diff --git a/CMakeLists.txt b/CMakeLists.txt index d2b005b6eff9..695796505338 100644 --- a/CMakeLists.txt +++ b/CMakeLists.txt @@ -3,7 +3,7 @@ project (KratosMultiphysics) # Set here the version number **** only update upon tagging a release! set (KratosMultiphysics_MAJOR_VERSION 5) -set (KratosMultiphysics_MINOR_VERSION 0) +set (KratosMultiphysics_MINOR_VERSION 1) set (KratosMultiphysics_PATCH_VERSION 0) # Define custom compiler build types diff --git a/applications/ALEapplication/custom_elements/structural_meshmoving_element.cpp b/applications/ALEapplication/custom_elements/structural_meshmoving_element.cpp index 61c8631415df..2fd3b062167b 100644 --- a/applications/ALEapplication/custom_elements/structural_meshmoving_element.cpp +++ b/applications/ALEapplication/custom_elements/structural_meshmoving_element.cpp @@ -448,32 +448,4 @@ void StructuralMeshMovingElement::CalculateRightHandSide(VectorType& rRightHandS } } -// Only called in the CalculateLocalSystem Function above -void StructuralMeshMovingElement::CalculateAndAddRHS(VectorType& rRightHandSideVector) -{ - const SizeType NumNodes = this->GetGeometry().PointsNumber(); - const unsigned int dimension = this->GetGeometry().WorkingSpaceDimension(); - - if (rRightHandSideVector.size() != mLocalSize) - rRightHandSideVector.resize(mLocalSize, false); - - GeometryType& rGeom = this->GetGeometry(); - for (SizeType iNode = 0; iNode < NumNodes; ++iNode) - { - // Note that we need to divide by the neighbours since the final RHS - // needs - // to be the desired value - //(the addition below is done as many times as elements we have where - // this node appears) - - int number_neighbours = rGeom[iNode].GetValue(NEIGHBOUR_ELEMENTS).size(); - - rRightHandSideVector[dimension * iNode + 0] += - rGeom[iNode].GetSolutionStepValue(MESH_RHS_X) / number_neighbours; - rRightHandSideVector[dimension * iNode + 1] += - rGeom[iNode].GetSolutionStepValue(MESH_RHS_Y) / number_neighbours; - rRightHandSideVector[dimension * iNode + 2] += - rGeom[iNode].GetSolutionStepValue(MESH_RHS_Z) / number_neighbours; - } -} } // Namespace Kratos diff --git a/applications/ALEapplication/custom_elements/structural_meshmoving_element.h b/applications/ALEapplication/custom_elements/structural_meshmoving_element.h index 3c97d2cac4d0..3b03286c0192 100644 --- a/applications/ALEapplication/custom_elements/structural_meshmoving_element.h +++ b/applications/ALEapplication/custom_elements/structural_meshmoving_element.h @@ -179,8 +179,6 @@ class StructuralMeshMovingElement : public Element void CalculateRightHandSide(VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo); - void CalculateAndAddRHS(VectorType& rRightHandSideVector); - ///@} ///@name Access ///@{ diff --git a/applications/ALEapplication/custom_python/add_custom_strategies_to_python.cpp b/applications/ALEapplication/custom_python/add_custom_strategies_to_python.cpp index c032ec9f3285..2fddad744c33 100644 --- a/applications/ALEapplication/custom_python/add_custom_strategies_to_python.cpp +++ b/applications/ALEapplication/custom_python/add_custom_strategies_to_python.cpp @@ -84,15 +84,14 @@ void AddCustomStrategiesToPython() bases< BaseSolvingStrategyType >, boost::noncopyable > ("LaplacianMeshMovingStrategy", init() ) - .def("MoveNodes",&LaplacianMeshMovingStrategy< SparseSpaceType, LocalSpaceType, LinearSolverType >::MoveNodes) ; class_< StructuralMeshMovingStrategy< SparseSpaceType, LocalSpaceType, LinearSolverType >, bases< BaseSolvingStrategyType >, boost::noncopyable > ("StructuralMeshMovingStrategy", init() ) - .def("MoveNodes",&StructuralMeshMovingStrategy< SparseSpaceType, LocalSpaceType, LinearSolverType >::MoveNodes) .def("UpdateReferenceMesh",&StructuralMeshMovingStrategy< SparseSpaceType, LocalSpaceType, LinearSolverType >::UpdateReferenceMesh) + .def("CalculateMeshVelocities",&StructuralMeshMovingStrategy< SparseSpaceType, LocalSpaceType, LinearSolverType >::CalculateMeshVelocities) ; } diff --git a/applications/ALEapplication/custom_strategies/strategies/laplacian_meshmoving_strategy.h b/applications/ALEapplication/custom_strategies/strategies/laplacian_meshmoving_strategy.h index 733df20d236b..e28dbe59d487 100644 --- a/applications/ALEapplication/custom_strategies/strategies/laplacian_meshmoving_strategy.h +++ b/applications/ALEapplication/custom_strategies/strategies/laplacian_meshmoving_strategy.h @@ -179,7 +179,10 @@ class LaplacianMeshMovingStrategy : public SolvingStrategySolve(); - MoveNodes(); + MoveMesh(); //clearing the system if needed if(mreform_dof_at_every_step == true) { @@ -267,14 +270,14 @@ class LaplacianMeshMovingStrategy : public SolvingStrategySetEchoLevel(Level); mstrategy_y->SetEchoLevel(Level); mstrategy_z->SetEchoLevel(Level); } - void MoveNodes() + void MoveMesh() override { for (ModelPart::NodeIterator i = BaseType::GetModelPart().NodesBegin(); i != BaseType::GetModelPart().NodesEnd(); ++i) diff --git a/applications/ALEapplication/custom_strategies/strategies/structural_meshmoving_strategy.h b/applications/ALEapplication/custom_strategies/strategies/structural_meshmoving_strategy.h index f82c826a388a..68822ae440bd 100644 --- a/applications/ALEapplication/custom_strategies/strategies/structural_meshmoving_strategy.h +++ b/applications/ALEapplication/custom_strategies/strategies/structural_meshmoving_strategy.h @@ -62,7 +62,6 @@ #include "solving_strategies/schemes/residualbased_incrementalupdate_static_scheme.h" #include "solving_strategies/builder_and_solvers/residualbased_block_builder_and_solver.h" #include "custom_elements/structural_meshmoving_element.h" -#include "processes/find_nodal_neighbours_process.h" #include "ale_application.h" @@ -153,8 +152,10 @@ class StructuralMeshMovingStrategy : public SolvingStrategySetEchoLevel(Level); } - void MoveNodes() + void MoveMesh() override { for (ModelPart::NodeIterator i = BaseType::GetModelPart().NodesBegin(); i != BaseType::GetModelPart().NodesEnd(); ++i) diff --git a/applications/ALEapplication/python_scripts/ale_navier_stokes_solver_vmsmonolithic.py b/applications/ALEapplication/python_scripts/ale_navier_stokes_solver_vmsmonolithic.py index a1e407ae3b66..2c2ca321d469 100644 --- a/applications/ALEapplication/python_scripts/ale_navier_stokes_solver_vmsmonolithic.py +++ b/applications/ALEapplication/python_scripts/ale_navier_stokes_solver_vmsmonolithic.py @@ -1,61 +1,55 @@ from __future__ import print_function, absolute_import, division -from KratosMultiphysics import * -from KratosMultiphysics.ALEApplication import * -from KratosMultiphysics.FluidDynamicsApplication import * -from KratosMultiphysics.ExternalSolversApplication import * -CheckForPreviousImport() - +import KratosMultiphysics +import KratosMultiphysics.ALEApplication as ALEApplication +import KratosMultiphysics.FluidDynamicsApplication as FluidDynamicsApplication +import KratosMultiphysics.ExternalSolversApplication as ExternalSolversApplication +KratosMultiphysics.CheckForPreviousImport() import navier_stokes_solver_vmsmonolithic + def CreateSolver(model_part, custom_settings): return ALENavierStokesSolverVMSMonolithic(model_part, custom_settings) -class ALENavierStokesSolverVMSMonolithic(navier_stokes_solver_vmsmonolithic.NavierStokesSolver_VMSMonolithic): +class ALENavierStokesSolverVMSMonolithic(navier_stokes_solver_vmsmonolithic.NavierStokesSolver_VMSMonolithic): def __init__(self, model_part, custom_settings): - # get ale solver type - self.ale_solver_type = custom_settings["ale_solver_type"].GetString() - valid_ale_solver_types = ["mesh_solver_structural_similarity"] - if self.ale_solver_type not in valid_ale_solver_types: - raise Exception("Invalid ale_solver_type: " + self.ale_solver_type) - # remove the ale solver type from settings so we can reuse the navier stokes constructor - navier_stokes_settings = custom_settings - navier_stokes_settings.RemoveValue("ale_solver_type") - # call navier stokes constructor - super().__init__(model_part, navier_stokes_settings) + # remove the ale_settings so we can use the navier stokes constructor + navier_stokes_settings = custom_settings.Clone() + navier_stokes_settings.RemoveValue("ale_settings") + super(ALENavierStokesSolverVMSMonolithic, self).__init__(model_part, navier_stokes_settings) # create ale solver - ale_solver_module = __import__(self.ale_solver_type) - ale_settings = Parameters("{}") # for now use default settings - self.ale_solver = ale_solver_module.CreateSolver(self.main_model_part, ale_settings) - print("Construction of ALENavierStokesSolverVMSMonolithic finished") + ale_solver_type = custom_settings["ale_settings"]["solver_type"].GetString() + valid_ale_solver_types = ["mesh_solver_structural_similarity"] + if ale_solver_type not in valid_ale_solver_types: + raise Exception("Invalid ALE solver_type: " + ale_solver_type) + ale_solver_module = __import__(ale_solver_type) + self.ale_solver = ale_solver_module.CreateSolver(self.main_model_part, custom_settings["ale_settings"]) + print("::[ALENavierStokesSolverVMSMonolithic]:: Construction finished") def AddVariables(self): - # add base class variables - super().AddVariables() - # add ale variables + super(ALENavierStokesSolverVMSMonolithic, self).AddVariables() self.ale_solver.AddVariables() - print("ALE variables added correctly") + print("::[ALENavierStokesSolverVMSMonolithic]:: Variables ADDED.") def AddDofs(self): - # add base class dofs - super().AddDofs() - # add ale dofs + super(ALENavierStokesSolverVMSMonolithic, self).AddDofs() self.ale_solver.AddDofs() - print("ALE dofs added correctly") + print("::[ALENavierStokesSolverVMSMonolithic]:: DOFs ADDED.") def Initialize(self): - super().Initialize() + super(ALENavierStokesSolverVMSMonolithic, self).Initialize() self.ale_solver.Initialize() + print("::[ALENavierStokesSolverVMSMonolithic]:: Finished initialization.") - def SolveFluid(self): - super().Solve() + def GetFluidSolver(self): + return super(ALENavierStokesSolverVMSMonolithic, self) - def SolveMeshMotion(self): - self.ale_solver.Solve() + def GetMeshMotionSolver(self): + return self.ale_solver def Solve(self): - self.SolveMeshMotion() - self.SolveFluid() + self.GetMeshMotionSolver().Solve() + self.GetFluidSolver().Solve() - def MoveNodes(self): - self.ale_solver.MoveNodes() + def MoveMesh(self): + self.GetMeshMotionSolver().MoveMesh() diff --git a/applications/ALEapplication/python_scripts/ale_trilinos_navier_stokes_solver_vmsmonolithic.py b/applications/ALEapplication/python_scripts/ale_trilinos_navier_stokes_solver_vmsmonolithic.py index d91d16d58ee7..376e9de26bc6 100644 --- a/applications/ALEapplication/python_scripts/ale_trilinos_navier_stokes_solver_vmsmonolithic.py +++ b/applications/ALEapplication/python_scripts/ale_trilinos_navier_stokes_solver_vmsmonolithic.py @@ -1,66 +1,62 @@ from __future__ import print_function, absolute_import, division -from KratosMultiphysics import * -from KratosMultiphysics.ALEApplication import * -from KratosMultiphysics.FluidDynamicsApplication import * +import KratosMultiphysics +import KratosMultiphysics.ALEApplication as ALEApplication +import KratosMultiphysics.FluidDynamicsApplication as FluidDynamicsApplication from KratosMultiphysics.mpi import * -from KratosMultiphysics.TrilinosApplication import * -from KratosMultiphysics.ExternalSolversApplication import * -CheckForPreviousImport() - +import KratosMultiphysics.TrilinosApplication as TrilinosApplication +KratosMultiphysics.CheckForPreviousImport() import trilinos_navier_stokes_solver_vmsmonolithic +import mesh_solver_base + def CreateSolver(model_part, custom_settings): return ALETrilinosNavierStokesSolverVMSMonolithic(model_part, custom_settings) -class ALETrilinosNavierStokesSolverVMSMonolithic(trilinos_navier_stokes_solver_vmsmonolithic.NavierStokesMPISolver_VMSMonolithic): +class ALETrilinosNavierStokesSolverVMSMonolithic(trilinos_navier_stokes_solver_vmsmonolithic.NavierStokesMPISolver_VMSMonolithic): def __init__(self, model_part, custom_settings): - # get ale solver type - self.ale_solver_type = custom_settings["ale_solver_type"].GetString() - valid_ale_solver_types = ["trilinos_mesh_solver_structural_similarity"] - if self.ale_solver_type not in valid_ale_solver_types: - raise Exception("Invalid ale_solver_type: " + self.ale_solver_type) - # remove the ale solver type from settings so we can reuse the navier stokes constructor - navier_stokes_settings = custom_settings - navier_stokes_settings.RemoveValue("ale_solver_type") - # call navier stokes constructor - super().__init__(model_part, navier_stokes_settings) + # remove the ale_settings so we can use the navier stokes constructor + navier_stokes_settings = custom_settings.Clone() + navier_stokes_settings.RemoveValue("ale_settings") + super(ALETrilinosNavierStokesSolverVMSMonolithic, self).__init__(model_part, navier_stokes_settings) # create ale solver - ale_solver_module = __import__(self.ale_solver_type) - ale_settings = Parameters("{}") # for now use default settings - self.ale_solver = ale_solver_module.CreateSolver(self.main_model_part, ale_settings) + ale_solver_type = custom_settings["ale_settings"]["solver_type"].GetString() + valid_ale_solver_types = ["trilinos_mesh_solver_structural_similarity"] + if ale_solver_type not in valid_ale_solver_types: + raise Exception("Invalid ALE solver_type: " + ale_solver_type) + ale_solver_module = __import__(ale_solver_type) + self.ale_solver = ale_solver_module.CreateSolver(self.main_model_part, custom_settings["ale_settings"]) if mpi.rank == 0: - print("Construction of ALENavierStokesSolverVMSMonolithic finished") + print("::[ALETrilinosNavierStokesSolverVMSMonolithic]:: Construction finished") def AddVariables(self): # add base class variables - super().AddVariables() - # add ale variables + super(ALETrilinosNavierStokesSolverVMSMonolithic, self).AddVariables() self.ale_solver.AddVariables() if mpi.rank == 0: - print("ALE variables added correctly") + print("::[ALETrilinosNavierStokesSolverVMSMonolithic]:: Variables ADDED.") def AddDofs(self): - # add base class dofs - super().AddDofs() - # add ale dofs + super(ALETrilinosNavierStokesSolverVMSMonolithic, self).AddDofs() self.ale_solver.AddDofs() if mpi.rank == 0: - print("ALE dofs added correctly") + print("::[ALETrilinosNavierStokesSolverVMSMonolithic]:: DOFs ADDED.") def Initialize(self): - super().Initialize() + super(ALETrilinosNavierStokesSolverVMSMonolithic, self).Initialize() self.ale_solver.Initialize() + if mpi.rank == 0: + print("::[ALETrilinosNavierStokesSolverVMSMonolithic]:: Finished initialization.") - def SolveFluid(self): - super().Solve() + def GetFluidSolver(self): + return super(ALETrilinosNavierStokesSolverVMSMonolithic, self) - def SolveMeshMotion(self): - self.ale_solver.Solve() + def GetMeshMotionSolver(self): + return self.ale_solver def Solve(self): - self.SolveMeshMotion() - self.SolveFluid() + self.GetMeshMotionSolver().Solve() + self.GetFluidSolver.Solve() - def MoveNodes(self): - self.ale_solver.MoveNodes() + def MoveMesh(self): + self.GetMeshMotionSolver().MoveMesh() diff --git a/applications/ALEapplication/python_scripts/mesh_solver_ballvertex.py b/applications/ALEapplication/python_scripts/mesh_solver_ballvertex.py index 81037d5e739e..79e54f307d6d 100644 --- a/applications/ALEapplication/python_scripts/mesh_solver_ballvertex.py +++ b/applications/ALEapplication/python_scripts/mesh_solver_ballvertex.py @@ -1,92 +1,73 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.ALEApplication import * -CheckForPreviousImport() - -# import mesh solver base class +import KratosMultiphysics +import KratosMultiphysics.ALEApplication as ALEApplication +KratosMultiphysics.CheckForPreviousImport() import mesh_solver_base + def CreateSolver(model_part, custom_settings): return MeshSolverBallvertex(model_part,custom_settings) class MeshSolverBallvertex(mesh_solver_base.MeshSolverBase): - def __init__(self, model_part, custom_settings): + super(MeshSolverBallvertex, self).__init__(model_part, custom_settings) + print("::[MeshSolverBallvertex]:: Construction finished") - # default settings for ballvertex mesh solver - default_settings = Parameters(""" - { - "mesh_reform_dofs_each_step": false - }""") - - custom_settings.ValidateAndAssignDefaults(default_settings) - - # assign parameters - self.model_part = model_part - self.domain_size = model_part.ProcessInfo[DOMAIN_SIZE] - self.mesh_reform_dofs_each_step = custom_settings["mesh_reform_dofs_each_step"].GetBool() - - # neighbour search - number_of_avg_elems = 10 - number_of_avg_nodes = 10 - self.neighbour_search = FindNodalNeighboursProcess(model_part, number_of_avg_elems, number_of_avg_nodes) - - # assignation of parameters to be used - self.time_order = 2 - - # definition of the solvers - # pILUPrecond = ILU0Preconditioner() - # self.linear_solver = BICGSTABSolver(1e-5, 300,pILUPrecond) - # pDiagPrecond = DiagonalPreconditioner() - # self.linear_solver = CGSolver(1e-3, 300, pDiagPrecond) - self.linear_solver = ScalingSolver(DeflatedCGSolver(1e-6, 3000, True, 1000), True) + #### Public user interface functions #### def AddVariables(self): - - self.model_part.AddNodalSolutionStepVariable(DISPLACEMENT) - self.model_part.AddNodalSolutionStepVariable(MESH_VELOCITY) - - print("Mesh solver variables added correctly.") + self.model_part.AddNodalSolutionStepVariable(KratosMultiphysics.DISPLACEMENT) + self.model_part.AddNodalSolutionStepVariable(KratosMultiphysics.MESH_VELOCITY) + print("::[MeshSolverBallvertex]:: Variables ADDED.") def AddDofs(self): - - for node in self.model_part.Nodes: - - node.AddDof(DISPLACEMENT_X) - node.AddDof(DISPLACEMENT_Y) - node.AddDof(DISPLACEMENT_Z) - - print("Mesh solver DOFs added correctly.") + KratosMultiphysics.VariableUtils().AddDof(KratosMultiphysics.DISPLACEMENT_X) + KratosMultiphysics.VariableUtils().AddDof(KratosMultiphysics.DISPLACEMENT_Y) + KratosMultiphysics.VariableUtils().AddDof(KratosMultiphysics.DISPLACEMENT_Z) + print("::[MeshSolverBallvertex]:: DOFs ADDED.") def Initialize(self): - (self.neighbour_search).Execute() - - if(self.domain_size == 2): - self.solver = BallVertexMeshMoving2D() - else: - self.solver = BallVertexMeshMoving3D() - - self.move_mesh_utilities = MoveMeshUtilities() - - if(self.mesh_reform_dofs_each_step == False): - self.solver.ConstructSystem(self.model_part) + number_of_avg_elems = 10 + number_of_avg_nodes = 10 + neighbour_search = FindNodalNeighboursProcess(self.model_part, + number_of_avg_elems, + number_of_avg_nodes) + neighbour_search.Execute() + solver = self.get_mesh_motion_solver() + if self.settings["reform_dofs_each_step"].GetBool() == False: + solver.ConstructSystem(self.model_part) + print("::[MeshSolverBallvertex]:: Finished initialization.") def Solve(self): - if(self.mesh_reform_dofs_each_step): + solver = self.get_mesh_motion_solver() + linear_solver = self.get_linear_solver() + if self.settings["reform_dofs_each_step"].GetBool() == True: (self.neighbour_search).Execute() + solver.ConstructSystem(self.model_part) + solver.BuildAndSolveSystem(self.model_part, linear_solver) + solver.ClearSystem() + else: + solver.BuildAndSolveSystem(model_part, linear_solver) + # Move mesh and calculate mesh velocity. + time_order = self.settings("time_order").GetInt() + ALEApplication.MoveMeshUtilities().BDF_MoveMesh(time_order, self.model_part) - self.solver.ConstructSystem(self.model_part) - - self.solver.BuildAndSolveSystem(self.model_part, self.linear_solver); + def MoveMesh(self): + time_order = self.settings("time_order").GetInt() + ALEApplication.MoveMeshUtilities().BDF_MoveMesh(time_order, self.model_part) - self.solver.ClearSystem() - else: - self.solver.BuildAndSolveSystem(self.model_part, self.linear_solver); + #### Private functions #### - # move mesh and calculate mesh velocity - self.move_mesh_utilities.BDF_MoveMesh(self.time_order, self.model_part) + def _create_linear_solver(self): + linear_solver = ScalingSolver(DeflatedCGSolver(1e-6, 3000, True, 1000), True) + return linear_solver - def MoveNodes(self): - self.move_mesh_utilities.BDF_MoveMesh(self.time_order, self.model_part) + def _create_mesh_motion_solver(self): + domain_size = self.model_part.ProcessInfo[DOMAIN_SIZE] + if(domain_size == 2): + solver = BallVertexMeshMoving2D() + else: + solver = BallVertexMeshMoving3D() + return solver diff --git a/applications/ALEapplication/python_scripts/mesh_solver_base.py b/applications/ALEapplication/python_scripts/mesh_solver_base.py index 442f80aa42a8..75af0c755fb8 100644 --- a/applications/ALEapplication/python_scripts/mesh_solver_base.py +++ b/applications/ALEapplication/python_scripts/mesh_solver_base.py @@ -9,57 +9,122 @@ def CreateSolver(model_part, custom_settings): return MeshSolverBase(model_part, custom_settings) -class MeshSolverBase: - +class MeshSolverBase(object): + """The base class for mesh motion solvers. + + This class defines the user interface to mesh motion solvers. + + Derived classes must override the function _create_mesh_motion_solver() + to customize the mesh motion algorithm. The mesh motion solver and linear + solver should always be retrieved using the getter functions. Only the + member variables listed below should be accessed directly. + + Public member variables: + settings -- Kratos parameters for general mesh motion settings. + model_part -- the mesh motion model part. + """ def __init__(self, model_part, custom_settings): - raise Exception("Base mesh solver Python constructor taken. Please implement the __init__ method in your mesh solver.") + default_settings = KratosMultiphysics.Parameters(""" + { + "solver_type" : "mesh_solver_structural_similarity", + "model_import_settings" : { + "input_type" : "mdpa", + "input_filename" : "unknown_name" + }, + "ale_linear_solver_settings" : { + "solver_type" : "AMGCL", + "smoother_type":"ilu0", + "krylov_type": "gmres", + "coarsening_type": "aggregation", + "max_iteration": 200, + "provide_coordinates": false, + "gmres_krylov_space_dimension": 100, + "verbosity" : 0, + "tolerance": 1e-7, + "scaling": false, + "block_size": 1, + "use_block_matrices_if_possible" : true, + "coarse_enough" : 5000 + }, + "time_order" : 2, + "reform_dofs_each_step" : false, + "compute_reactions" : false + }""") + self.settings = custom_settings + self.settings.ValidateAndAssignDefaults(default_settings) + self.model_part = model_part + print("::[MeshSolverBase]:: Construction finished") + + #### Public user interface functions #### def AddVariables(self): self.model_part.AddNodalSolutionStepVariable(KratosMultiphysics.MESH_DISPLACEMENT) self.model_part.AddNodalSolutionStepVariable(KratosMultiphysics.MESH_VELOCITY) self.model_part.AddNodalSolutionStepVariable(KratosMultiphysics.MESH_REACTION) - self.model_part.AddNodalSolutionStepVariable(KratosMultiphysics.MESH_RHS) - - print("Mesh base solver variables added correctly.") + print("::[MeshSolverBase]:: Variables ADDED.") def AddDofs(self): - for node in self.model_part.Nodes: - node.AddDof(KratosMultiphysics.MESH_DISPLACEMENT_X, KratosMultiphysics.MESH_REACTION_X) - node.AddDof(KratosMultiphysics.MESH_DISPLACEMENT_Y, KratosMultiphysics.MESH_REACTION_Y) - node.AddDof(KratosMultiphysics.MESH_DISPLACEMENT_Z, KratosMultiphysics.MESH_REACTION_Z) - - print("Mesh base solver DOFs added correctly.") + KratosMultiphysics.VariableUtils().AddDof(KratosMultiphysics.MESH_DISPLACEMENT_X, self.model_part) + KratosMultiphysics.VariableUtils().AddDof(KratosMultiphysics.MESH_DISPLACEMENT_Y, self.model_part) + KratosMultiphysics.VariableUtils().AddDof(KratosMultiphysics.MESH_DISPLACEMENT_Z, self.model_part) + print("::[MeshSolverBase]:: DOFs ADDED.") def Initialize(self): - raise Exception("Base mesh solver method taken. Please implement the Initialize() method in your mesh solver.") + self.get_mesh_motion_solver().Initialize() + print("::[MeshSolverBase]:: Finished initialization.") - def Solve(self): - if(self.mesh_reform_dofs_each_step): - (self.neighbour_search).Execute() + def InitializeSolutionStep(self): + self.get_mesh_motion_solver().InitializeSolutionStep() - (self.solver).Solve() + def FinalizeSolutionStep(self): + self.get_mesh_motion_solver().FinalizeSolutionStep() - + def SetEchoLevel(self, level): + self.get_mesh_motion_solver().SetEchoLevel(level) - def MoveNodes(self): - (self.solver).MoveNodes() + def GetEchoLevel(self): + self.get_mesh_motion_solver().GetEchoLevel() - def ImportModelPart(self): - - print("::[Mechanical Solver]:: Model reading starts.") + def Solve(self): + self.get_mesh_motion_solver().Solve() - self.computing_model_part_name = "computing_domain" #this submodelpart will be labeled with KratosMultiphysics.ACTIVE flag, you can recover it checking the flag. - - if(self.settings["model_import_settings"]["input_type"].GetString() == "mdpa"): - - # Model part reading - KratosMultiphysics.ModelPartIO(self.settings["model_import_settings"]["input_filename"].GetString()).ReadModelPart(self.model_part) - print(" Import input model part.") + def Clear(self): + self.get_mesh_motion_solver().Clear() - # Set and fill buffer - #self._SetAndFillBuffer() + def Check(self): + self.get_mesh_motion_solver().Check() + def MoveMesh(self): + self.get_mesh_motion_solver().MoveMesh() + + def ImportModelPart(self): + raise Exception("::[MeshSolverBase]:: ImportModelPart() is not implemented yet.") def GetComputingModelPart(self): - #return self.main_model_part.GetSubModelPart(self.computing_model_part_name) return self.model_part + + #### Specific internal functions #### + + def get_linear_solver(self): + if not hasattr(self, '_linear_solver'): + self._linear_solver = self._create_linear_solver() + return self._linear_solver + + def get_mesh_motion_solver(self): + if not hasattr(self, '_mesh_motion_solver'): + self._mesh_motion_solver = self._create_mesh_motion_solver() + return self._mesh_motion_solver + + #### Private functions #### + + def _create_linear_solver(self): + import linear_solver_factory + linear_solver = linear_solver_factory.ConstructSolver(self.settings["ale_linear_solver_settings"]) + return linear_solver + + def _create_mesh_motion_solver(self): + """Create the mesh motion solver. + + The mesh motion solver must provide the functions defined in SolutionStrategy. + """ + raise Exception("Mesh motion solver must be created by the derived class.") diff --git a/applications/ALEapplication/python_scripts/mesh_solver_laplacian.py b/applications/ALEapplication/python_scripts/mesh_solver_laplacian.py index 61efa29d63e5..97bebf2abd77 100644 --- a/applications/ALEapplication/python_scripts/mesh_solver_laplacian.py +++ b/applications/ALEapplication/python_scripts/mesh_solver_laplacian.py @@ -1,100 +1,27 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.ALEApplication import * -from KratosMultiphysics.ExternalSolversApplication import * -CheckForPreviousImport() -# -# -# def AddVariables(model_part): -# -# model_part.AddNodalSolutionStepVariable(MESH_DISPLACEMENT) -# model_part.AddNodalSolutionStepVariable(MESH_VELOCITY) -# model_part.AddNodalSolutionStepVariable(MESH_REACTION) -# model_part.AddNodalSolutionStepVariable(MESH_RHS) -# -# print("Mesh solver variables added correctly.") -# -# -# def AddDofs(model_part): -# -# for node in model_part.Nodes: -# node.AddDof(MESH_DISPLACEMENT_X, MESH_REACTION_X) -# node.AddDof(MESH_DISPLACEMENT_Y, MESH_REACTION_Y) -# node.AddDof(MESH_DISPLACEMENT_Z, MESH_REACTION_Z) -# -# print("Mesh solver DOFs added correctly.") - -# import mesh solver base class +import KratosMultiphysics +import KratosMultiphysics.ALEApplication as ALEApplication +KratosMultiphysics.CheckForPreviousImport() import mesh_solver_base + def CreateSolver(model_part, custom_settings): return MeshSolverLaplacian(model_part, custom_settings) class MeshSolverLaplacian(mesh_solver_base.MeshSolverBase): - def __init__(self, model_part, custom_settings): - - # default settings for laplacian mesh solver - default_settings = Parameters(""" - { - "solver_type" : "mesh_solver_laplacian", - "model_import_settings" : { - "input_type" : "mdpa", - "input_filename" : "unknown_name" - }, - "ale_linear_solver_settings" : { - "solver_type" : "AMGCL", - "smoother_type":"ilu0", - "krylov_type": "gmres", - "coarsening_type": "aggregation", - "max_iteration": 200, - "provide_coordinates": false, - "gmres_krylov_space_dimension": 100, - "verbosity" : 0, - "tolerance": 1e-7, - "scaling": false, - "block_size": 1, - "use_block_matrices_if_possible" : true, - "coarse_enough" : 5000 - }, - "volume_model_part_name" : "volume_model_part", - "time_order" : 2, - "mesh_reform_dofs_each_step" : false, - "mesh_compute_reactions" : false - }""") - - self.settings = custom_settings - self.settings.ValidateAndAssignDefaults(default_settings) - - # assign parameters - self.model_part = model_part - self.time_order = custom_settings["time_order"].GetInt() - self.mesh_reform_dofs_each_step = custom_settings["mesh_reform_dofs_each_step"].GetBool() - - # neighbour search - number_of_avg_elems = 10 - number_of_avg_nodes = 10 - self.neighbour_search = FindNodalNeighboursProcess(model_part, number_of_avg_elems, number_of_avg_nodes) - - # definition of the solvers - import new_linear_solver_factory - self.linear_solver = new_linear_solver_factory.ConstructSolver(self.settings["ale_linear_solver_settings"]) - print("Construction of MeshSolverLaplacian finished") - - def Initialize(self): - (self.neighbour_search).Execute() - - self.solver = LaplacianMeshMovingStrategy(self.model_part, self.linear_solver, self.time_order, self.mesh_reform_dofs_each_step) - (self.solver).SetEchoLevel(0) - print("finished moving the mesh") - - # def Solve(self): - # if(self.mesh_reform_dofs_each_step): - # (self.neighbour_search).Execute() - # - # (self.solver).Solve() - # - # def MoveNodes(self): - # (self.solver).MoveNodes() + super(MeshSolverLaplacian, self).__init__(model_part, custom_settings) + print("::[MeshSolverLaplacian]:: Construction finished") + + def _create_mesh_motion_solver(self): + linear_solver = self.get_linear_solver() + time_order = self.settings["time_order"].GetInt() + reform_dofs_at_each_step = self.settings["reform_dofs_each_step"].GetBool() + compute_reactions = self.settings["compute_reactions"].GetBool() + solver = ALEApplication.LaplacianMeshMovingStrategy(self.model_part, + linear_solver, + time_order, + reform_dofs_each_step) + return solver diff --git a/applications/ALEapplication/python_scripts/mesh_solver_structural_similarity.py b/applications/ALEapplication/python_scripts/mesh_solver_structural_similarity.py index bf17964c1cf2..c02b34f51634 100644 --- a/applications/ALEapplication/python_scripts/mesh_solver_structural_similarity.py +++ b/applications/ALEapplication/python_scripts/mesh_solver_structural_similarity.py @@ -1,98 +1,28 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.ALEApplication import * -from KratosMultiphysics.ExternalSolversApplication import * -CheckForPreviousImport() - -# import mesh solver base class +import KratosMultiphysics +import KratosMultiphysics.ALEApplication as ALEApplication +KratosMultiphysics.CheckForPreviousImport() import mesh_solver_base + def CreateSolver(model_part, custom_settings): return MeshSolverStructuralSimilarity(model_part, custom_settings) class MeshSolverStructuralSimilarity(mesh_solver_base.MeshSolverBase): - def __init__(self, model_part, custom_settings): - - # default settings for structural similarity mesh solver - default_settings = Parameters(""" - { - "solver_type" : "mesh_solver_structural_similarity", - "model_import_settings" : { - "input_type" : "mdpa", - "input_filename" : "unknown_name" - }, - "ale_linear_solver_settings" : { - "solver_type" : "AMGCL", - "smoother_type":"ilu0", - "krylov_type": "gmres", - "coarsening_type": "aggregation", - "max_iteration": 200, - "provide_coordinates": false, - "gmres_krylov_space_dimension": 100, - "verbosity" : 0, - "tolerance": 1e-7, - "scaling": false, - "block_size": 1, - "use_block_matrices_if_possible" : true, - "coarse_enough" : 5000 - }, - "volume_model_part_name" : "volume_model_part", - "time_order" : 2, - "mesh_reform_dofs_each_step" : false, - "mesh_compute_reactions" : false - }""") - - self.settings = custom_settings - self.settings.ValidateAndAssignDefaults(default_settings) - - # set parameters - self.model_part = model_part - self.time_order = custom_settings["time_order"].GetInt() - self.mesh_compute_reactions = custom_settings["mesh_compute_reactions"].GetBool() - self.mesh_reform_dofs_each_step = custom_settings["mesh_reform_dofs_each_step"].GetBool() - - # neighbour search - number_of_avg_elems = 10 - number_of_avg_nodes = 10 - self.neighbour_search = FindNodalNeighboursProcess(model_part, number_of_avg_elems, number_of_avg_nodes) - - # definition of the solvers - import linear_solver_factory - self.linear_solver = linear_solver_factory.ConstructSolver(self.settings["ale_linear_solver_settings"]) - print("Construction of MeshSolverStructuralSimilarity finished") - ''' - def AddVariables(self): - self.model_part.AddNodalSolutionStepVariable(MESH_DISPLACEMENT) - self.model_part.AddNodalSolutionStepVariable(MESH_VELOCITY) - self.model_part.AddNodalSolutionStepVariable(MESH_REACTION) - self.model_part.AddNodalSolutionStepVariable(MESH_RHS) - print("Mesh solver variables added correctly.") - - def AddDofs(self): - for node in self.model_part.Nodes: - node.AddDof(MESH_DISPLACEMENT_X, MESH_REACTION_X) - node.AddDof(MESH_DISPLACEMENT_Y, MESH_REACTION_Y) - node.AddDof(MESH_DISPLACEMENT_Z, MESH_REACTION_Z) - print("Mesh solver DOFs added correctly.") - ''' - def Initialize(self): - (self.neighbour_search).Execute() - - # Initialize mesh model part - for node in self.model_part.Nodes: - zero = Vector(3) - zero[0] = 0.0 - zero[1] = 0.0 - zero[2] = 0.0 - node.SetSolutionStepValue(MESH_REACTION,0,zero) - node.SetSolutionStepValue(MESH_DISPLACEMENT,0,zero) - node.SetSolutionStepValue(MESH_RHS,0,zero) - - self.solver = StructuralMeshMovingStrategy(self.model_part, self.linear_solver, self.time_order, self.mesh_reform_dofs_each_step, self.mesh_compute_reactions) - (self.solver).SetEchoLevel(0) - - def UpdateReferenceMesh(self): - (self.solver).UpdateReferenceMesh() + super(MeshSolverStructuralSimilarity, self).__init__(model_part, custom_settings) + print("::[MeshSolverStructuralSimilarity]:: Construction finished") + + def _create_mesh_motion_solver(self): + linear_solver = self.get_linear_solver() + time_order = self.settings["time_order"].GetInt() + reform_dofs_each_step = self.settings["reform_dofs_each_step"].GetBool() + compute_reactions = self.settings["compute_reactions"].GetBool() + solver = ALEApplication.StructuralMeshMovingStrategy(self.model_part, + linear_solver, + time_order, + reform_dofs_each_step, + compute_reactions) + return solver diff --git a/applications/ALEapplication/tests/test_MainKratos.py b/applications/ALEapplication/tests/test_MainKratos.py index ea7508eb25ca..9eb9fa508d56 100644 --- a/applications/ALEapplication/tests/test_MainKratos.py +++ b/applications/ALEapplication/tests/test_MainKratos.py @@ -102,7 +102,7 @@ def Solve(self): #self.gid_output.ExecuteInitializeSolutionStep() if(step >= 3): - self.solver.SolveMeshMotion() + self.solver.GetMeshMotionSolver().Solve() for process in self.list_of_processes: process.ExecuteFinalizeSolutionStep() diff --git a/applications/ALEapplication/tests/test_structural_mesh_motion_2d/mpi_rectangle_2D3N_test_parameters.json b/applications/ALEapplication/tests/test_structural_mesh_motion_2d/mpi_rectangle_2D3N_test_parameters.json index 25761e8f0f88..1b86b3428571 100644 --- a/applications/ALEapplication/tests/test_structural_mesh_motion_2d/mpi_rectangle_2D3N_test_parameters.json +++ b/applications/ALEapplication/tests/test_structural_mesh_motion_2d/mpi_rectangle_2D3N_test_parameters.json @@ -36,7 +36,9 @@ }, "solver_settings" : { "solver_type" : "ale_trilinos_navier_stokes_solver_vmsmonolithic", - "ale_solver_type" : "trilinos_mesh_solver_structural_similarity", + "ale_settings" : { + "solver_type" : "trilinos_mesh_solver_structural_similarity" + }, "model_import_settings" : { "input_type" : "mdpa", "input_filename" : "test_structural_mesh_motion_2d/rectangle_2D3N_test" diff --git a/applications/ALEapplication/tests/test_structural_mesh_motion_2d/rectangle_2D3N_test_parameters.json b/applications/ALEapplication/tests/test_structural_mesh_motion_2d/rectangle_2D3N_test_parameters.json index 00134bcfde19..a0446fd848b3 100644 --- a/applications/ALEapplication/tests/test_structural_mesh_motion_2d/rectangle_2D3N_test_parameters.json +++ b/applications/ALEapplication/tests/test_structural_mesh_motion_2d/rectangle_2D3N_test_parameters.json @@ -36,7 +36,9 @@ }, "solver_settings" : { "solver_type" : "ale_navier_stokes_solver_vmsmonolithic", - "ale_solver_type" : "mesh_solver_structural_similarity", + "ale_settings" : { + "solver_type" : "mesh_solver_structural_similarity" + }, "model_import_settings" : { "input_type" : "mdpa", "input_filename" : "test_structural_mesh_motion_2d/rectangle_2D3N_test" diff --git a/applications/CMakeLists.txt b/applications/CMakeLists.txt index f440a95ece62..40b24c9ae27c 100644 --- a/applications/CMakeLists.txt +++ b/applications/CMakeLists.txt @@ -2,55 +2,56 @@ set(CMAKE_INCLUDE_CURRENT_DIR ON) #echo of user defined options message( " ") -message("INCOMPRESSIBLE_FLUID_APPLICATION ... ${INCOMPRESSIBLE_FLUID_APPLICATION}") -message("MESHING_APPLICATION ................ ${MESHING_APPLICATION}") -message("EXTERNAL_SOLVERS_APPLICATION........ ${EXTERNAL_SOLVERS_APPLICATION}") -message("PFEM_APPLICATION.................... ${PFEM_APPLICATION}") -message("STRUCTURAL_APPLICATION.............. ${STRUCTURAL_APPLICATION}") -message("STRUCTURAL_MECHANICS_APPLICATION.... ${STRUCTURAL_MECHANICS_APPLICATION}") -message("CONVECTION_DIFFUSION_APPLICATION.... ${CONVECTION_DIFFUSION_APPLICATION}") -message("SOLID_MECHANICS_APPLICATION......... ${SOLID_MECHANICS_APPLICATION}") -message("PFEM_BASE_APPLICATION............... ${PFEM_BASE_APPLICATION}") -message("PFEM_SOLID_MECHANICS_APPLICATION.... ${PFEM_SOLID_MECHANICS_APPLICATION}") -message("MACHINING_APPLICATION............... ${MACHINING_APPLICATION}") -message("FLUID_DYNAMICS_APPLICATION.......... ${FLUID_DYNAMICS_APPLICATION}") -message("PFEM_FLUID_DYNAMICS_APPLICATION..... ${PFEM_FLUID_DYNAMICS_APPLICATION}") -message("STRING_DYNAMICS_APPLICATION......... ${STRING_DYNAMICS_APPLICATION}") -message("ALE_APPLICATION..................... ${ALE_APPLICATION}") -message("FSI_APPLICATION..................... ${FSI_APPLICATION}") -message("EMPIRE_APPLICATION.................. ${EMPIRE_APPLICATION}") -message("MIXED_ELEMENT_APPLICATION........... ${MIXED_ELEMENT_APPLICATION}") -message("DEM_APPLICATION..................... ${DEM_APPLICATION}") -message("SWIMMING_DEM_APPLICATION............ ${SWIMMING_DEM_APPLICATION}") -message("CONSTITUTIVE_LAWS_APPLICATION....... ${CONSTITUTIVE_LAWS_APPLICATION}") -message("THERMO_MECHANICAL_APPLICATION....... ${THERMO_MECHANICAL_APPLICATION}") -message("OPENCL_APPLICATION.................. ${OPENCL_APPLICATION}") -message("MKL_SOLVERS_APPLICATION............. ${MKL_SOLVERS_APPLICATION}") -message("MPI_SEARCH_APPLICATION.............. ${MPI_SEARCH_APPLICATION}") -message("METIS_APPLICATION................... ${METIS_APPLICATION}") -message("TRILINOS_APPLICATION................ ${TRILINOS_APPLICATION}") -message("TURBULENT_FLOW_APPLICATION.......... ${TURBULENT_FLOW_APPLICATION}") -message("BLOOD_FLOW_APPLICATION.............. ${BLOOD_FLOW_APPLICATION}") -message("PURE_DIFFUSION_APPLICATION.......... ${PURE_DIFFUSION_APPLICATION}") -message("MESHLESS_APPLICATION................ ${MESHLESS_APPLICATION}") -message("WIND_TURBINE_APPLICATION ........... ${WIND_TURBINE_APPLICATION}") -message("CLICK2CAST_APPLICATION ............. ${CLICK2CAST_APPLICATION}") -message("MULTISCALE_APPLICATION ............. ${MULTISCALE_APPLICATION}") -message("PFEM2_APPLICATION................... ${PFEM2_APPLICATION}") -message("FREEZING_SOIL_APPLICATION........... ${FREEZING_SOIL_APPLICATION}") -message("ADJOINT_FLUID_APPLICATION........... ${ADJOINT_FLUID_APPLICATION}") -message("POROMECHANICS_APPLICATION........... ${POROMECHANICS_APPLICATION}") -message("PARTICLE_MECHANICS_APPLICATION...... ${PARTICLE_MECHANICS_APPLICATION}") -message("FORMING_APPLICATION................. ${FORMING_APPLICATION}") -message("DAM_APPLICATION..................... ${DAM_APPLICATION}") -message("SHAPE_OPTIMIZATION_APPLICATION...... ${SHAPE_OPTIMIZATION_APPLICATION}") -message("TOPOLOGY_OPTIMIZATION_APPLICATION... ${TOPOLOGY_OPTIMIZATION_APPLICATION}") -message("MY_LAPLACIAN_APPLICATION............ ${MY_LAPLACIAN_APPLICATION}") -message("LAGRANGIAN_MPM_APPLICATION.......... ${LAGRANGIAN_MPM_APPLICATION}") -message("CONTACT_MECHANICS_APPLICATION....... ${CONTACT_MECHANICS_APPLICATION}") -message("CONTACT_STRUCTURAL_MECHANICS_APPLICATION....... ${CONTACT_STRUCTURAL_MECHANICS_APPLICATION}") -message("MAPPING_APPLICATION................. ${MAPPING_APPLICATION}") -message("CONSTITUTIVE_MODELS_APPLICATION..... ${CONSTITUTIVE_MODELS_APPLICATION}") +message("MESHING_APPLICATION ....................... ${MESHING_APPLICATION}") +message("EXTERNAL_SOLVERS_APPLICATION............... ${EXTERNAL_SOLVERS_APPLICATION}") +message("STRUCTURAL_APPLICATION..................... ${STRUCTURAL_APPLICATION}") +message("STRUCTURAL_MECHANICS_APPLICATION........... ${STRUCTURAL_MECHANICS_APPLICATION}") +message("FLUID_DYNAMICS_APPLICATION................. ${FLUID_DYNAMICS_APPLICATION}") +message("CONVECTION_DIFFUSION_APPLICATION........... ${CONVECTION_DIFFUSION_APPLICATION}") +message("SOLID_MECHANICS_APPLICATION................ ${SOLID_MECHANICS_APPLICATION}") +message("CONTACT_MECHANICS_APPLICATION.............. ${CONTACT_MECHANICS_APPLICATION}") +message("CONSTITUTIVE_MODELS_APPLICATION............ ${CONSTITUTIVE_MODELS_APPLICATION}") +message("PFEM_APPLICATION........................... ${PFEM_APPLICATION}") +message("PFEM_FLUID_DYNAMICS_APPLICATION............ ${PFEM_FLUID_DYNAMICS_APPLICATION}") +message("PFEM_SOLID_MECHANICS_APPLICATION........... ${PFEM_SOLID_MECHANICS_APPLICATION}") +message("PFEM2_APPLICATION.......................... ${PFEM2_APPLICATION}") +message("MACHINING_APPLICATION...................... ${MACHINING_APPLICATION}") +message("STRING_DYNAMICS_APPLICATION................ ${STRING_DYNAMICS_APPLICATION}") +message("ALE_APPLICATION............................ ${ALE_APPLICATION}") +message("FSI_APPLICATION............................ ${FSI_APPLICATION}") +message("EMPIRE_APPLICATION......................... ${EMPIRE_APPLICATION}") +message("MIXED_ELEMENT_APPLICATION.................. ${MIXED_ELEMENT_APPLICATION}") +message("DEM_APPLICATION............................ ${DEM_APPLICATION}") +message("SWIMMING_DEM_APPLICATION................... ${SWIMMING_DEM_APPLICATION}") +message("CONSTITUTIVE_LAWS_APPLICATION.............. ${CONSTITUTIVE_LAWS_APPLICATION}") +message("THERMO_MECHANICAL_APPLICATION.............. ${THERMO_MECHANICAL_APPLICATION}") +message("OPENCL_APPLICATION......................... ${OPENCL_APPLICATION}") +message("MKL_SOLVERS_APPLICATION.................... ${MKL_SOLVERS_APPLICATION}") +message("MPI_SEARCH_APPLICATION..................... ${MPI_SEARCH_APPLICATION}") +message("METIS_APPLICATION.......................... ${METIS_APPLICATION}") +message("TRILINOS_APPLICATION....................... ${TRILINOS_APPLICATION}") +message("TURBULENT_FLOW_APPLICATION................. ${TURBULENT_FLOW_APPLICATION}") +message("BLOOD_FLOW_APPLICATION..................... ${BLOOD_FLOW_APPLICATION}") +message("PURE_DIFFUSION_APPLICATION................. ${PURE_DIFFUSION_APPLICATION}") +message("MESHLESS_APPLICATION....................... ${MESHLESS_APPLICATION}") +message("WIND_TURBINE_APPLICATION .................. ${WIND_TURBINE_APPLICATION}") +message("CLICK2CAST_APPLICATION .................... ${CLICK2CAST_APPLICATION}") +message("MULTISCALE_APPLICATION .................... ${MULTISCALE_APPLICATION}") +message("FREEZING_SOIL_APPLICATION.................. ${FREEZING_SOIL_APPLICATION}") +message("ADJOINT_FLUID_APPLICATION.................. ${ADJOINT_FLUID_APPLICATION}") +message("POROMECHANICS_APPLICATION.................. ${POROMECHANICS_APPLICATION}") +message("PARTICLE_MECHANICS_APPLICATION............. ${PARTICLE_MECHANICS_APPLICATION}") +message("FORMING_APPLICATION........................ ${FORMING_APPLICATION}") +message("DAM_APPLICATION............................ ${DAM_APPLICATION}") +message("SHAPE_OPTIMIZATION_APPLICATION............. ${SHAPE_OPTIMIZATION_APPLICATION}") +message("TOPOLOGY_OPTIMIZATION_APPLICATION.......... ${TOPOLOGY_OPTIMIZATION_APPLICATION}") +message("MY_LAPLACIAN_APPLICATION................... ${MY_LAPLACIAN_APPLICATION}") +message("LAGRANGIAN_MPM_APPLICATION................. ${LAGRANGIAN_MPM_APPLICATION}") +message("CONTACT_STRUCTURAL_MECHANICS_APPLICATION... ${CONTACT_STRUCTURAL_MECHANICS_APPLICATION}") +message("MAPPING_APPLICATION........................ ${MAPPING_APPLICATION}") +message("INCOMPRESSIBLE_FLUID_APPLICATION .......... ${INCOMPRESSIBLE_FLUID_APPLICATION}") +message("COMPRESSIBLE_POTENTIAL_FLOW_APPLICATION.... ${COMPRESSIBLE_POTENTIAL_FLOW_APPLICATION}") + message( " ") @@ -59,10 +60,6 @@ if(${INSTALL_PYTHON_FILES} MATCHES ON) endif(${INSTALL_PYTHON_FILES} MATCHES ON) #include subdirectories for compilation -if(${INCOMPRESSIBLE_FLUID_APPLICATION} MATCHES ON) - add_subdirectory(incompressible_fluid_application) -endif(${INCOMPRESSIBLE_FLUID_APPLICATION} MATCHES ON) - if(${MESHING_APPLICATION} MATCHES ON) add_subdirectory(MeshingApplication) endif(${MESHING_APPLICATION} MATCHES ON) @@ -71,10 +68,6 @@ if(${EXTERNAL_SOLVERS_APPLICATION} MATCHES ON) add_subdirectory(ExternalSolversApplication) endif(${EXTERNAL_SOLVERS_APPLICATION} MATCHES ON) -if(${PFEM_APPLICATION} MATCHES ON) - add_subdirectory(PFEMapplication) -endif(${PFEM_APPLICATION} MATCHES ON) - if(${STRUCTURAL_APPLICATION} MATCHES ON) add_subdirectory(structural_application) endif(${STRUCTURAL_APPLICATION} MATCHES ON) @@ -163,22 +156,34 @@ if(${SOLID_MECHANICS_APPLICATION} MATCHES ON) add_subdirectory(SolidMechanicsApplication) endif(${SOLID_MECHANICS_APPLICATION} MATCHES ON) -if(${PFEM_BASE_APPLICATION} MATCHES ON) - add_subdirectory(PfemBaseApplication) -endif(${PFEM_BASE_APPLICATION} MATCHES ON) +if(${CONTACT_MECHANICS_APPLICATION} MATCHES ON) + add_subdirectory(ContactMechanicsApplication) +endif(${CONTACT_MECHANICS_APPLICATION} MATCHES ON) + +if(${CONSTITUTIVE_MODELS_APPLICATION} MATCHES ON) + add_subdirectory(ConstitutiveModelsApplication) +endif(${CONSTITUTIVE_MODELS_APPLICATION} MATCHES ON) + +if(${PFEM_APPLICATION} MATCHES ON) + add_subdirectory(PfemApplication) +endif(${PFEM_APPLICATION} MATCHES ON) + +if(${PFEM_FLUID_DYNAMICS_APPLICATION} MATCHES ON) + add_subdirectory(PfemFluidDynamicsApplication) +endif(${PFEM_FLUID_DYNAMICS_APPLICATION} MATCHES ON) if(${PFEM_SOLID_MECHANICS_APPLICATION} MATCHES ON) add_subdirectory(PfemSolidMechanicsApplication) endif(${PFEM_SOLID_MECHANICS_APPLICATION} MATCHES ON) +if(${PFEM2_APPLICATION} MATCHES ON) + add_subdirectory(pfem_2_application) +endif(${PFEM2_APPLICATION} MATCHES ON) + if(${MACHINING_APPLICATION} MATCHES ON) add_subdirectory(MachiningApplication) endif(${MACHINING_APPLICATION} MATCHES ON) -if(${PFEM_FLUID_DYNAMICS_APPLICATION} MATCHES ON) - add_subdirectory(PfemFluidDynamicsApplication) -endif(${PFEM_FLUID_DYNAMICS_APPLICATION} MATCHES ON) - if(${STRING_DYNAMICS_APPLICATION} MATCHES ON) add_subdirectory(StringDynamicsApplication) endif(${STRING_DYNAMICS_APPLICATION} MATCHES ON) @@ -211,10 +216,6 @@ if(${NURBS_APPLICATION} MATCHES ON) add_subdirectory(nurbs_application) endif(${NURBS_APPLICATION} MATCHES ON) -if(${PFEM2_APPLICATION} MATCHES ON) - add_subdirectory(pfem_2_application) -endif(${PFEM2_APPLICATION} MATCHES ON) - if(${FREEZING_SOIL_APPLICATION} MATCHES ON) add_subdirectory(freezing_soil_application) endif(${FREEZING_SOIL_APPLICATION} MATCHES ON) @@ -251,10 +252,6 @@ if(${LAGRANGIAN_MPM_APPLICATION} MATCHES ON) add_subdirectory(LagrangianMPMApplication) endif(${LAGRANGIAN_MPM_APPLICATION} MATCHES ON) -if(${CONTACT_MECHANICS_APPLICATION} MATCHES ON) - add_subdirectory(ContactMechanicsApplication) -endif(${CONTACT_MECHANICS_APPLICATION} MATCHES ON) - if(${CONTACT_STRUCTURAL_MECHANICS_APPLICATION} MATCHES ON) add_subdirectory(ContactStructuralMechanicsApplication) endif(${CONTACT_STRUCTURAL_MECHANICS_APPLICATION} MATCHES ON) @@ -263,9 +260,9 @@ if(${MAPPING_APPLICATION} MATCHES ON) add_subdirectory(MappingApplication) endif(${MAPPING_APPLICATION} MATCHES ON) -if(${CONSTITUTIVE_MODELS_APPLICATION} MATCHES ON) - add_subdirectory(ConstitutiveModelsApplication) -endif(${CONSTITUTIVE_MODELS_APPLICATION} MATCHES ON) +if(${INCOMPRESSIBLE_FLUID_APPLICATION} MATCHES ON) + add_subdirectory(incompressible_fluid_application) +endif(${INCOMPRESSIBLE_FLUID_APPLICATION} MATCHES ON) if(${COMPRESSIBLE_POTENTIAL_FLOW_APPLICATION} MATCHES ON) add_subdirectory(CompressiblePotentialFlowApplication) diff --git a/applications/CompressiblePotentialFlowApplication/python_scripts/apply_far_field_process.py b/applications/CompressiblePotentialFlowApplication/python_scripts/apply_far_field_process.py index 9574295bf893..5c6fd703edf5 100644 --- a/applications/CompressiblePotentialFlowApplication/python_scripts/apply_far_field_process.py +++ b/applications/CompressiblePotentialFlowApplication/python_scripts/apply_far_field_process.py @@ -36,8 +36,12 @@ def Execute(self): for cond in self.model_part.Conditions: cond.SetValue(KratosMultiphysics.VELOCITY, self.velocity_infinity) + #select the first node + for node in self.model_part.Nodes: + node1 = node + break + #find the node with the minimal x - node1 = self.model_part.Nodes[1] x0 = node1.X y0 = node1.X z0 = node1.X diff --git a/applications/ContactMechanicsApplication/CMakeLists.txt b/applications/ContactMechanicsApplication/CMakeLists.txt index 32cf73a4cdce..5d6efadca246 100644 --- a/applications/ContactMechanicsApplication/CMakeLists.txt +++ b/applications/ContactMechanicsApplication/CMakeLists.txt @@ -3,12 +3,12 @@ set(CMAKE_INCLUDE_CURRENT_DIR ON) message("**** configuring KratosContactMechanicsApplication ****") include_directories( ${CMAKE_SOURCE_DIR}/kratos ) -include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/../PfemBaseApplication ) +include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/../PfemApplication ) -if(NOT (${PFEM_BASE_APPLICATION} MATCHES "ON")) - message(SEND_ERROR "The Pfem Base Application must be compiled before this one. Set PFEM_BASE_APPLICATION=ON in the configure file.") -endif(NOT (${PFEM_BASE_APPLICATION} MATCHES "ON")) +if(NOT (${PFEM_APPLICATION} MATCHES "ON")) + message(SEND_ERROR "The Pfem Base Application must be compiled before this one. Set PFEM_APPLICATION=ON in the configure file.") +endif(NOT (${PFEM_APPLICATION} MATCHES "ON")) if(NOT DEFINED ${INCLUDE_TRIANGLE}) set(INCLUDE_TRIANGLE ON) @@ -71,7 +71,7 @@ set( KRATOS_CONTACT_MECHANICS_APPLICATION_SOURCES # define library Kratos which defines the basic python interface add_library(KratosContactMechanicsApplication SHARED ${KRATOS_CONTACT_MECHANICS_APPLICATION_SOURCES}) -target_link_libraries(KratosContactMechanicsApplication KratosCore KratosPfemBaseApplication) +target_link_libraries(KratosContactMechanicsApplication KratosCore KratosPfemApplication) set_target_properties(KratosContactMechanicsApplication PROPERTIES PREFIX "") set_target_properties(KratosContactMechanicsApplication PROPERTIES COMPILE_DEFINITIONS "CONTACT_MECHANICS_APPLICATION=EXPORT,API") install(TARGETS KratosContactMechanicsApplication DESTINATION libs ) diff --git a/applications/ContactMechanicsApplication/contact_mechanics_application.h b/applications/ContactMechanicsApplication/contact_mechanics_application.h index f8d6291bd75d..beda2a07da0f 100644 --- a/applications/ContactMechanicsApplication/contact_mechanics_application.h +++ b/applications/ContactMechanicsApplication/contact_mechanics_application.h @@ -57,7 +57,7 @@ // Core applications -#include "pfem_base_application.h" +#include "pfem_application.h" #include "contact_mechanics_application_variables.h" diff --git a/applications/ContactMechanicsApplication/contact_mechanics_application_variables.h b/applications/ContactMechanicsApplication/contact_mechanics_application_variables.h index 75977a9ef928..4ae512259fe1 100644 --- a/applications/ContactMechanicsApplication/contact_mechanics_application_variables.h +++ b/applications/ContactMechanicsApplication/contact_mechanics_application_variables.h @@ -30,7 +30,7 @@ // Project includes // Core applications -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos { diff --git a/applications/ContactMechanicsApplication/python_scripts/contact_domain.py b/applications/ContactMechanicsApplication/python_scripts/contact_domain.py index 9d070ae9921e..5ce9352bf56b 100644 --- a/applications/ContactMechanicsApplication/python_scripts/contact_domain.py +++ b/applications/ContactMechanicsApplication/python_scripts/contact_domain.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact # Check that KratosMultiphysics was imported in the main script @@ -110,7 +110,7 @@ def Initialize(self): def SetRefiningParameters(self): #no refine in the contact domain # Create RefiningParameters - self.RefiningParameters = KratosPfemBase.RefiningParameters() + self.RefiningParameters = KratosPfem.RefiningParameters() self.RefiningParameters.Initialize() # parameters diff --git a/applications/ContactMechanicsApplication/python_scripts/contact_domain_process.py b/applications/ContactMechanicsApplication/python_scripts/contact_domain_process.py index b7e2ee915641..3faf5ba2401c 100644 --- a/applications/ContactMechanicsApplication/python_scripts/contact_domain_process.py +++ b/applications/ContactMechanicsApplication/python_scripts/contact_domain_process.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact KratosMultiphysics.CheckForPreviousImport() @@ -83,7 +83,7 @@ def ExecuteInitialize(self): # execute initialize base class - if( self.main_model_part.ProcessInfo[KratosPfemBase.INITIALIZED_DOMAINS] == False ): + if( self.main_model_part.ProcessInfo[KratosPfem.INITIALIZED_DOMAINS] == False ): import domain_utilities domain_utils = domain_utilities.DomainUtilities() domain_utils.InitializeDomains(self.main_model_part,self.echo_level) @@ -96,7 +96,7 @@ def ExecuteInitialize(self): # def ExecuteInitializeSolutionStep(self): self.step_count += 1 - meshing_step_performed = self.main_model_part.ProcessInfo[KratosPfemBase.MESHING_STEP_PERFORMED] + meshing_step_performed = self.main_model_part.ProcessInfo[KratosPfem.MESHING_STEP_PERFORMED] restart_performed = self.main_model_part.ProcessInfo[KratosMultiphysics.IS_RESTARTED] #if( not restart_performed ): if(self.IsMeshingStep() or meshing_step_performed): diff --git a/applications/ContactMechanicsApplication/python_scripts/contact_meshing_strategy.py b/applications/ContactMechanicsApplication/python_scripts/contact_meshing_strategy.py index 961122dc34ae..c227c522b43d 100644 --- a/applications/ContactMechanicsApplication/python_scripts/contact_meshing_strategy.py +++ b/applications/ContactMechanicsApplication/python_scripts/contact_meshing_strategy.py @@ -2,7 +2,7 @@ #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact # Check that KratosMultiphysics was imported in the main script @@ -63,9 +63,9 @@ def Initialize(self,meshing_parameters,domain_size): meshing_options = KratosMultiphysics.Flags() - meshing_options.Set(KratosPfemBase.ModelerUtilities.REMESH, self.settings["remesh"].GetBool()) - meshing_options.Set(KratosPfemBase.ModelerUtilities.CONSTRAINED, self.settings["constrained"].GetBool()) - meshing_options.Set(KratosPfemBase.ModelerUtilities.CONTACT_SEARCH, True) + meshing_options.Set(KratosPfem.ModelerUtilities.REMESH, self.settings["remesh"].GetBool()) + meshing_options.Set(KratosPfem.ModelerUtilities.CONSTRAINED, self.settings["constrained"].GetBool()) + meshing_options.Set(KratosPfem.ModelerUtilities.CONTACT_SEARCH, True) self.MeshingParameters.SetOptions(meshing_options) self.MeshingParameters.SetReferenceCondition(self.settings["contact_parameters"]["contact_condition_type"].GetString()) @@ -105,8 +105,8 @@ def Initialize(self,meshing_parameters,domain_size): self.MeshingParameters.SetProperties(properties) #set variables to global transfer - self.MeshDataTransfer = KratosPfemBase.MeshDataTransferUtilities() - self.TransferParameters = KratosPfemBase.TransferParameters() + self.MeshDataTransfer = KratosPfem.MeshDataTransferUtilities() + self.TransferParameters = KratosPfem.TransferParameters() self.global_transfer = False #mesh modelers for the current strategy @@ -128,14 +128,14 @@ def Initialize(self,meshing_parameters,domain_size): transfer_options = transfer_parameters.GetOptions() if( self.main_model_part.ProcessInfo[KratosMultiphysics.IS_RESTARTED] == False ): - transfer_options.Set(KratosPfemBase.MeshDataTransferUtilities.INITIALIZE_MASTER_CONDITION, True) + transfer_options.Set(KratosPfem.MeshDataTransferUtilities.INITIALIZE_MASTER_CONDITION, True) transfer_parameters.SetOptions(transfer_options) self.MeshDataTransfer.TransferBoundaryData(transfer_parameters,self.main_model_part,self.mesh_id) # set flags for the transfer needed for the contact domain - transfer_options.Set(KratosPfemBase.MeshDataTransferUtilities.INITIALIZE_MASTER_CONDITION, False) - transfer_options.Set(KratosPfemBase.MeshDataTransferUtilities.MASTER_ELEMENT_TO_MASTER_CONDITION, True) + transfer_options.Set(KratosPfem.MeshDataTransferUtilities.INITIALIZE_MASTER_CONDITION, False) + transfer_options.Set(KratosPfem.MeshDataTransferUtilities.MASTER_ELEMENT_TO_MASTER_CONDITION, True) transfer_parameters.SetOptions(transfer_options) diff --git a/applications/ContactMechanicsApplication/python_scripts/contact_modeler.py b/applications/ContactMechanicsApplication/python_scripts/contact_modeler.py index 7021dfa8a974..4da64df73215 100644 --- a/applications/ContactMechanicsApplication/python_scripts/contact_modeler.py +++ b/applications/ContactMechanicsApplication/python_scripts/contact_modeler.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact # Check that KratosMultiphysics was imported in the main script @@ -49,18 +49,18 @@ def InitializeMeshing(self): # set execution flags: to set the options to be executed in methods and processes execution_options = KratosMultiphysics.Flags() - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, True) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, True) self.MeshingParameters.SetExecutionOptions(execution_options) @@ -72,7 +72,7 @@ def InitializeMeshing(self): modeler_info = "Reconnect a cloud of points" if( self.domain_size == 2 ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pBYYQ" else: modeler_flags = "QNP" @@ -80,7 +80,7 @@ def InitializeMeshing(self): elif( self.domain_size == 3 ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): #modeler_flags = "pMYYCJFu0" modeler_flags = "pJFBMYYCCQu0" else: @@ -104,11 +104,11 @@ def SetPostMeshingProcesses(self): # The order set is the order of execution: #print GiD mesh output for checking purposes - print_output_mesh = KratosPfemBase.PrintOutputMeshProcess(self.model_part, self.MeshingParameters, self.echo_level) + print_output_mesh = KratosPfem.PrintOutputMeshProcess(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(print_output_mesh) #select mesh elements - select_mesh_elements = KratosPfemBase.SelectMeshElements(self.model_part, self.MeshingParameters, self.echo_level) + select_mesh_elements = KratosPfem.SelectMeshElements(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(select_mesh_elements) # build contact conditions diff --git a/applications/ContactMechanicsApplication/python_scripts/parametric_walls_process.py b/applications/ContactMechanicsApplication/python_scripts/parametric_walls_process.py index aa46b1099cae..c23ccddaeca3 100644 --- a/applications/ContactMechanicsApplication/python_scripts/parametric_walls_process.py +++ b/applications/ContactMechanicsApplication/python_scripts/parametric_walls_process.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact KratosMultiphysics.CheckForPreviousImport() diff --git a/applications/ContactMechanicsApplication/python_scripts/rigid_bodies_process.py b/applications/ContactMechanicsApplication/python_scripts/rigid_bodies_process.py index 3c20205156b7..32445826bf6b 100644 --- a/applications/ContactMechanicsApplication/python_scripts/rigid_bodies_process.py +++ b/applications/ContactMechanicsApplication/python_scripts/rigid_bodies_process.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact KratosMultiphysics.CheckForPreviousImport() diff --git a/applications/ContactMechanicsApplication/python_scripts/rigid_body.py b/applications/ContactMechanicsApplication/python_scripts/rigid_body.py index e4bf9c842073..c19fc5a098d7 100644 --- a/applications/ContactMechanicsApplication/python_scripts/rigid_body.py +++ b/applications/ContactMechanicsApplication/python_scripts/rigid_body.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact # Check that KratosMultiphysics was imported in the main script @@ -90,7 +90,7 @@ def __init__(self, main_model_part, custom_settings): box_parameters["lower_point"][counter].SetDouble(i) counter+=1 - self.bounding_box = KratosPfemBase.SpatialBoundingBox(box_settings) + self.bounding_box = KratosPfem.SpatialBoundingBox(box_settings) # construct rigid element // must pass an array of nodes to the element, create a node (CG) and a rigid element set them in the model_part, set the node CG as the reference node of the wall_bounding_box, BLOCKED, set in the wall_model_part for imposed movements processes. creation_utility = KratosContact.RigidBodyCreationUtility() diff --git a/applications/DEM_application/custom_utilities/inlet.cpp b/applications/DEM_application/custom_utilities/inlet.cpp index 29c5b4f92855..ec09293dc7b8 100644 --- a/applications/DEM_application/custom_utilities/inlet.cpp +++ b/applications/DEM_application/custom_utilities/inlet.cpp @@ -479,22 +479,22 @@ namespace Kratos { else { int number_of_added_spheres = 0; - Cluster3D* p_cluster = creator.ClusterCreatorWithPhysicalParameters(r_modelpart, - r_clusters_modelpart, - max_Id+1, - valid_elements[random_pos]->GetGeometry()(0), - valid_elements[random_pos], - //This only works for random_pos as real position in the vector if - //we use ModelPart::NodesContainerType::ContainerType instead of ModelPart::NodesContainerType - p_properties, - mp, - r_reference_element, - p_fast_properties, - mBallsModelPartHasSphericity, - mBallsModelPartHasRotation, - smp_it->Elements(), - number_of_added_spheres, - mStrategyForContinuum); + creator.ClusterCreatorWithPhysicalParameters(r_modelpart, + r_clusters_modelpart, + max_Id+1, + valid_elements[random_pos]->GetGeometry()(0), + valid_elements[random_pos], + //This only works for random_pos as real position in the vector if + //we use ModelPart::NodesContainerType::ContainerType instead of ModelPart::NodesContainerType + p_properties, + mp, + r_reference_element, + p_fast_properties, + mBallsModelPartHasSphericity, + mBallsModelPartHasRotation, + smp_it->Elements(), + number_of_added_spheres, + mStrategyForContinuum); //UpdatePartialThroughput(*p_cluster, smp_number); max_Id += number_of_added_spheres; diff --git a/applications/DamApplication/custom_constitutive/linear_elastic_3D_law_nodal.cpp b/applications/DamApplication/custom_constitutive/linear_elastic_3D_law_nodal.cpp index 1a87a41df677..8a439a82b455 100644 --- a/applications/DamApplication/custom_constitutive/linear_elastic_3D_law_nodal.cpp +++ b/applications/DamApplication/custom_constitutive/linear_elastic_3D_law_nodal.cpp @@ -65,14 +65,14 @@ void LinearElastic3DLawNodal::CalculateMaterialResponseKirchhoff (Parameters& rV if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ) //TOTAL STRESS { - StressVector = prod(ConstitutiveMatrix,StrainVector); + noalias(StressVector) = prod(ConstitutiveMatrix,StrainVector); } } else if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ) //TOTAL STRESS { this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); - StressVector = prod(ConstitutiveMatrix,StrainVector); + noalias(StressVector) = prod(ConstitutiveMatrix,StrainVector); } diff --git a/applications/DamApplication/custom_constitutive/thermal_linear_elastic_3D_law.cpp b/applications/DamApplication/custom_constitutive/thermal_linear_elastic_3D_law.cpp index a2ff2f0aaa60..0e1d3d0e4738 100755 --- a/applications/DamApplication/custom_constitutive/thermal_linear_elastic_3D_law.cpp +++ b/applications/DamApplication/custom_constitutive/thermal_linear_elastic_3D_law.cpp @@ -50,8 +50,8 @@ void ThermalLinearElastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& //0.- Initialize parameters MaterialResponseVariables ElasticVariables; - ElasticVariables.SetShapeFunctionsValues(rValues.GetShapeFunctionsValues()); - ElasticVariables.SetElementGeometry(rValues.GetElementGeometry()); + ElasticVariables.SetShapeFunctionsValues(rValues.GetShapeFunctionsValues()); + ElasticVariables.SetElementGeometry(rValues.GetElementGeometry()); //1.- Lame constants const double& YoungModulus = MaterialProperties[YOUNG_MODULUS]; @@ -64,41 +64,33 @@ void ThermalLinearElastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& ElasticVariables.ThermalExpansionCoefficient = MaterialProperties[THERMAL_EXPANSION]; ElasticVariables.ReferenceTemperature = CurrentProcessInfo[REFERENCE_TEMPERATURE]; - if(Options.Is( ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR )) - { - this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); + if(Options.Is( ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR )){ + + this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); + + if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ){ //TOTAL STRESS - if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ) //TOTAL STRESS - { - double Temperature; - this->CalculateDomainTemperature( ElasticVariables, Temperature); - - Vector ThermalStrainVector; - this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables,Temperature); - - StressVector = prod(ConstitutiveMatrix,(StrainVector - ThermalStrainVector)); - } - } - else if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ) //TOTAL STRESS - { - this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); - double Temperature; this->CalculateDomainTemperature( ElasticVariables, Temperature); Vector ThermalStrainVector; this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables,Temperature); - StressVector = prod(ConstitutiveMatrix,(StrainVector - ThermalStrainVector)); + Vector tmp(StrainVector.size()); + noalias(tmp) = StrainVector - ThermalStrainVector; + noalias(StressVector) = prod(ConstitutiveMatrix,tmp); + } } - else if( Options.Is( ConstitutiveLaw::TOTAL_TENSOR ) ) //This should be COMPUTE_MECHANICAL_STRESS - { + else if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ){ //TOTAL STRESS + + if( Options.Is( ConstitutiveLaw::MECHANICAL_RESPONSE_ONLY ) ){ //This should be COMPUTE_MECHANICAL_STRESS + this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); - StressVector = prod(ConstitutiveMatrix,StrainVector); - } - else if( Options.Is( ConstitutiveLaw::VOLUMETRIC_TENSOR_ONLY ) ) //This should be COMPUTE_THERMAL_STRESS - { + noalias(StressVector) = prod(ConstitutiveMatrix,StrainVector); + } + else if( Options.Is( ConstitutiveLaw::THERMAL_RESPONSE_ONLY ) ){ //This should be COMPUTE_THERMAL_STRESS + this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); double Temperature; @@ -106,14 +98,37 @@ void ThermalLinearElastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& this->CalculateThermalStrain(StrainVector,ElasticVariables,Temperature); - StressVector = prod(ConstitutiveMatrix,StrainVector); - } - else if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN ) ) //This should be COMPUTE_THERMAL_STRAIN - { + noalias(StressVector) = prod(ConstitutiveMatrix,StrainVector); + } + else{ + + this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); + double Temperature; this->CalculateDomainTemperature( ElasticVariables, Temperature); + + Vector ThermalStrainVector; + this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables,Temperature); + + Vector tmp(StrainVector.size()); + noalias(tmp) = StrainVector - ThermalStrainVector; + noalias(StressVector) = prod(ConstitutiveMatrix,tmp); + } + + } + else if(Options.Is(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN)){ //This should be COMPUTE_THERMAL_STRAIN + + // USE_ELEMENT_PROVIDED_STRAIN + if(Options.Is(ConstitutiveLaw::THERMAL_RESPONSE_ONLY)){ + + // Thermal strain + double Temperature; + this->CalculateDomainTemperature( ElasticVariables, Temperature); - this->CalculateThermalStrain(StrainVector,ElasticVariables,Temperature); + this->CalculateThermalStrain(StrainVector,ElasticVariables,Temperature); + } + //other strain: to implement + } KRATOS_CATCH( "" ) diff --git a/applications/DamApplication/custom_constitutive/thermal_linear_elastic_3D_law_nodal.cpp b/applications/DamApplication/custom_constitutive/thermal_linear_elastic_3D_law_nodal.cpp index e3bbd4bf30db..66f62ef29904 100644 --- a/applications/DamApplication/custom_constitutive/thermal_linear_elastic_3D_law_nodal.cpp +++ b/applications/DamApplication/custom_constitutive/thermal_linear_elastic_3D_law_nodal.cpp @@ -50,8 +50,8 @@ void ThermalLinearElastic3DLawNodal::CalculateMaterialResponseKirchhoff (Paramet //0.- Initialize parameters MaterialResponseVariables ElasticVariables; - ElasticVariables.SetShapeFunctionsValues(rValues.GetShapeFunctionsValues()); - ElasticVariables.SetElementGeometry(rValues.GetElementGeometry()); + ElasticVariables.SetShapeFunctionsValues(rValues.GetShapeFunctionsValues()); + ElasticVariables.SetElementGeometry(rValues.GetElementGeometry()); //1.- Lame constants double YoungModulus; @@ -65,56 +65,73 @@ void ThermalLinearElastic3DLawNodal::CalculateMaterialResponseKirchhoff (Paramet ElasticVariables.ThermalExpansionCoefficient = MaterialProperties[THERMAL_EXPANSION]; ElasticVariables.ReferenceTemperature = CurrentProcessInfo[REFERENCE_TEMPERATURE]; - if(Options.Is( ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR )) - { - this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); + if(Options.Is( ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR )){ + + this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); - if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ) //TOTAL STRESS - { - double Temperature; - this->CalculateDomainTemperature( ElasticVariables, Temperature); - - Vector ThermalStrainVector; - this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables,Temperature); - - StressVector = prod(ConstitutiveMatrix,(StrainVector - ThermalStrainVector)); - } - } - else if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ) //TOTAL STRESS - { - this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); - + if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ){ //TOTAL STRESS + double Temperature; this->CalculateDomainTemperature( ElasticVariables, Temperature); Vector ThermalStrainVector; this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables,Temperature); - StressVector = prod(ConstitutiveMatrix,(StrainVector - ThermalStrainVector)); - } - else if( Options.Is( ConstitutiveLaw::TOTAL_TENSOR ) ) //This should be COMPUTE_MECHANICAL_STRESS - { - this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); - - StressVector = prod(ConstitutiveMatrix,StrainVector); + Vector tmp(StrainVector.size()); + noalias(tmp) = StrainVector - ThermalStrainVector; + noalias(StressVector) = prod(ConstitutiveMatrix,tmp); + } } - else if( Options.Is( ConstitutiveLaw::VOLUMETRIC_TENSOR_ONLY ) ) //This should be COMPUTE_THERMAL_STRESS - { + else if( Options.Is( ConstitutiveLaw::COMPUTE_STRESS ) ){ //TOTAL STRESS + + if( Options.Is( ConstitutiveLaw::MECHANICAL_RESPONSE_ONLY ) ){ //This should be COMPUTE_MECHANICAL_STRESS + + this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); + + noalias(StressVector) = prod(ConstitutiveMatrix,StrainVector); + } + else if( Options.Is( ConstitutiveLaw::THERMAL_RESPONSE_ONLY ) ){ //This should be COMPUTE_THERMAL_STRESS + + this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); + + double Temperature; + this->CalculateDomainTemperature( ElasticVariables, Temperature); + + this->CalculateThermalStrain(StrainVector,ElasticVariables,Temperature); + + noalias(StressVector) = prod(ConstitutiveMatrix,StrainVector); + } + else{ + this->CalculateLinearElasticMatrix( ConstitutiveMatrix, YoungModulus, PoissonCoefficient ); - + double Temperature; this->CalculateDomainTemperature( ElasticVariables, Temperature); + + Vector ThermalStrainVector; + this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables,Temperature); - this->CalculateThermalStrain(StrainVector,ElasticVariables,Temperature); + Vector tmp(StrainVector.size()); + noalias(tmp) = StrainVector - ThermalStrainVector; + noalias(StressVector) = prod(ConstitutiveMatrix,tmp); + + } - StressVector = prod(ConstitutiveMatrix,StrainVector); } - else if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN ) ) //This should be COMPUTE_THERMAL_STRAIN - { - double Temperature; - this->CalculateDomainTemperature( ElasticVariables, Temperature); - - this->CalculateThermalStrain(StrainVector,ElasticVariables,Temperature); + else if(Options.Is(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN)){ //This should be COMPUTE_THERMAL_STRAIN + + // USE_ELEMENT_PROVIDED_STRAIN + if(Options.Is(ConstitutiveLaw::THERMAL_RESPONSE_ONLY)){ + + double Temperature; + this->CalculateDomainTemperature( ElasticVariables, Temperature); + + // Thermal strain + this->CalculateThermalStrain(StrainVector,ElasticVariables,Temperature); + + } + //other strain: to implement + } KRATOS_CATCH( "" ) diff --git a/applications/DamApplication/custom_constitutive/thermal_local_damage_3D_law.cpp b/applications/DamApplication/custom_constitutive/thermal_local_damage_3D_law.cpp index b80cf8b05f97..7120856ca2e4 100644 --- a/applications/DamApplication/custom_constitutive/thermal_local_damage_3D_law.cpp +++ b/applications/DamApplication/custom_constitutive/thermal_local_damage_3D_law.cpp @@ -78,8 +78,8 @@ void ThermalLocalDamage3DLaw::CalculateMaterialResponseCauchy (Parameters& rValu // MaterialResponseVariables (Thermal variables) HyperElastic3DLaw::MaterialResponseVariables ElasticVariables; - ElasticVariables.SetShapeFunctionsValues(rValues.GetShapeFunctionsValues()); - ElasticVariables.SetElementGeometry(rValues.GetElementGeometry()); + ElasticVariables.SetShapeFunctionsValues(rValues.GetShapeFunctionsValues()); + ElasticVariables.SetElementGeometry(rValues.GetElementGeometry()); ElasticVariables.LameMu = 1.0+PoissonCoefficient; ElasticVariables.ThermalExpansionCoefficient = MaterialProperties[THERMAL_EXPANSION]; ElasticVariables.ReferenceTemperature = rValues.GetProcessInfo()[REFERENCE_TEMPERATURE]; @@ -97,81 +97,91 @@ void ThermalLocalDamage3DLaw::CalculateMaterialResponseCauchy (Parameters& rValu this->CalculateCharacteristicSize(CharacteristicSize,rValues.GetElementGeometry()); ReturnMappingVariables.CharacteristicSize = CharacteristicSize; - if(Options.Is(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR)) //TOTAL STRESS - { - // Thermal strain - Vector ThermalStrainVector(VoigtSize); - this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables); - // Mechanical strain - noalias(rStrainVector) -= ThermalStrainVector; - noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); - noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; + if(Options.Is(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR)){ //TOTAL STRESS + + // Thermal strain + Vector ThermalStrainVector(VoigtSize); + this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables); + // Mechanical strain + noalias(rStrainVector) -= ThermalStrainVector; + noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); + noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; - if(Options.IsNot(ConstitutiveLaw::COMPUTE_STRESS)) - { - // COMPUTE_CONSTITUTIVE_TENSOR - Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); - Vector EffectiveStressVector(VoigtSize); - - this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,EffectiveStressVector,LinearElasticMatrix,rStrainVector); - - this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); - } - else - { - // COMPUTE_CONSTITUTIVE_TENSOR && COMPUTE_STRESS - Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); - Vector& rStressVector = rValues.GetStressVector(); + if(Options.IsNot(ConstitutiveLaw::COMPUTE_STRESS)){ + + // COMPUTE_CONSTITUTIVE_TENSOR + Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); + Vector EffectiveStressVector(VoigtSize); + + this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,EffectiveStressVector,LinearElasticMatrix,rStrainVector); + + this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); + } + else{ + + // COMPUTE_CONSTITUTIVE_TENSOR && COMPUTE_STRESS + Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); + Vector& rStressVector = rValues.GetStressVector(); - this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); + this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); - this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); - } + this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); + } } - else if(Options.Is(ConstitutiveLaw::COMPUTE_STRESS)) //TOTAL STRESS - { + else if(Options.Is(ConstitutiveLaw::COMPUTE_STRESS)){ //TOTAL STRESS + + if(Options.Is(ConstitutiveLaw::MECHANICAL_RESPONSE_ONLY)){ //This should be COMPUTE_MECHANICAL_STRESS + // COMPUTE_STRESS Vector& rStressVector = rValues.GetStressVector(); - - // Thermal strain - Vector ThermalStrainVector(VoigtSize); - this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables); - // Mechanical strain - noalias(rStrainVector) -= ThermalStrainVector; + + // Total Strain noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); - } - else if(Options.Is(ConstitutiveLaw::TOTAL_TENSOR)) //This should be COMPUTE_MECHANICAL_STRESS - { - // COMPUTE_STRESS + } + else if(Options.Is(ConstitutiveLaw::THERMAL_RESPONSE_ONLY)){ //This should be COMPUTE_THERMAL_STRESS + + // COMPUTE_STRESS Vector& rStressVector = rValues.GetStressVector(); - - // Total Strain + + // Thermal strain + this->CalculateThermalStrain(rStrainVector,ElasticVariables); noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); - } - else if(Options.Is(ConstitutiveLaw::VOLUMETRIC_TENSOR_ONLY)) //This should be COMPUTE_THERMAL_STRESS - { - // COMPUTE_STRESS + } + else{ + + // COMPUTE_STRESS Vector& rStressVector = rValues.GetStressVector(); // Thermal strain - this->CalculateThermalStrain(rStrainVector,ElasticVariables); + Vector ThermalStrainVector(VoigtSize); + this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables); + // Mechanical strain + noalias(rStrainVector) -= ThermalStrainVector; noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); + + } + + } - else if(Options.Is(ConstitutiveLaw::COMPUTE_STRAIN)) //This should be COMPUTE_THERMAL_STRAIN - { - // COMPUTE_STRAIN - - // Thermal strain - this->CalculateThermalStrain(rStrainVector,ElasticVariables); + else if(Options.Is(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN)){ //This should be COMPUTE_THERMAL_STRAIN + + // USE_ELEMENT_PROVIDED_STRAIN + if(Options.Is(ConstitutiveLaw::THERMAL_RESPONSE_ONLY)){ + + // Thermal strain + this->CalculateThermalStrain(rStrainVector,ElasticVariables); + } + //other strain: to implement + } } @@ -280,4 +290,4 @@ void ThermalLocalDamage3DLaw::CalculateThermalStrain(Vector& rThermalStrainVecto KRATOS_CATCH( "" ) } -} // Namespace Kratos \ No newline at end of file +} // Namespace Kratos diff --git a/applications/DamApplication/custom_constitutive/thermal_nonlocal_damage_3D_law.cpp b/applications/DamApplication/custom_constitutive/thermal_nonlocal_damage_3D_law.cpp index e35db95223d6..4d630822f7e8 100644 --- a/applications/DamApplication/custom_constitutive/thermal_nonlocal_damage_3D_law.cpp +++ b/applications/DamApplication/custom_constitutive/thermal_nonlocal_damage_3D_law.cpp @@ -59,44 +59,148 @@ ConstitutiveLaw::Pointer ThermalNonlocalDamage3DLaw::Clone() const void ThermalNonlocalDamage3DLaw::CalculateMaterialResponseCauchy (Parameters& rValues) { - // Check - rValues.CheckAllParameters(); + // Check + rValues.CheckAllParameters(); - // Get values for the constitutive law - Flags& Options = rValues.GetOptions(); - const Properties& MaterialProperties = rValues.GetMaterialProperties(); - Vector& rStrainVector = rValues.GetStrainVector(); + // Get values for the constitutive law + Flags& Options = rValues.GetOptions(); + const Properties& MaterialProperties = rValues.GetMaterialProperties(); + Vector& rStrainVector = rValues.GetStrainVector(); + + // Initialize main variables // + + // LinearElasticMatrix + const double& YoungModulus = MaterialProperties[YOUNG_MODULUS]; + const double& PoissonCoefficient = MaterialProperties[POISSON_RATIO]; + const unsigned int VoigtSize = rStrainVector.size(); + Matrix LinearElasticMatrix (VoigtSize,VoigtSize); + this->CalculateLinearElasticMatrix(LinearElasticMatrix,YoungModulus,PoissonCoefficient); + + // MaterialResponseVariables (Thermal variables) + HyperElastic3DLaw::MaterialResponseVariables ElasticVariables; + ElasticVariables.SetShapeFunctionsValues(rValues.GetShapeFunctionsValues()); + ElasticVariables.SetElementGeometry(rValues.GetElementGeometry()); + ElasticVariables.LameMu = 1.0+PoissonCoefficient; + ElasticVariables.ThermalExpansionCoefficient = MaterialProperties[THERMAL_EXPANSION]; + ElasticVariables.ReferenceTemperature = rValues.GetProcessInfo()[REFERENCE_TEMPERATURE]; + + // ReturnMappingVariables + FlowRule::RadialReturnVariables ReturnMappingVariables; + ReturnMappingVariables.initialize(); + // Strain and Stress matrices + const unsigned int Dim = this->WorkingSpaceDimension(); + Matrix AuxMatrix(Dim,Dim); + ReturnMappingVariables.StrainMatrix.resize(Dim,Dim,false); + ReturnMappingVariables.TrialIsoStressMatrix.resize(Dim,Dim,false); + // CharacteristicSize (for nonlocal damage it must be 1.0) + ReturnMappingVariables.CharacteristicSize = 1.0; + + if(Options.Is(ConstitutiveLaw::INITIALIZE_MATERIAL_RESPONSE)) // LOCAL QUANTITIES + { + // Thermal strain + Vector ThermalStrainVector(VoigtSize); + this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables); + // Mechanical strain + noalias(rStrainVector) -= ThermalStrainVector; + noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); + noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; + + if(Options.Is(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR)) // Compute constitutive tensor and total stress + { + if(Options.IsNot(ConstitutiveLaw::COMPUTE_STRESS)) + { + // COMPUTE_CONSTITUTIVE_TENSOR + Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); + Vector EffectiveStressVector(VoigtSize); + + this->CalculateLocalReturnMapping(ReturnMappingVariables,AuxMatrix,EffectiveStressVector,LinearElasticMatrix,rStrainVector); + + this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); + } + else + { + // COMPUTE_CONSTITUTIVE_TENSOR && COMPUTE_STRESS + Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); + Vector& rStressVector = rValues.GetStressVector(); + + this->CalculateLocalReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); + + this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); + } + } + else if(Options.Is(ConstitutiveLaw::COMPUTE_STRESS)) // Compute total stress + { + // COMPUTE_STRESS + Vector& rStressVector = rValues.GetStressVector(); + + this->CalculateLocalReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); + } + } + else // NON LOCAL QUANTITIES + { + ReturnMappingVariables.NormIsochoricStress = mNonlocalEquivalentStrain; + + if(Options.Is(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR)) // Compute constitutive tensor and total stress + { + // Thermal strain + Vector ThermalStrainVector(VoigtSize); + this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables); + // Mechanical strain + noalias(rStrainVector) -= ThermalStrainVector; + noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); + noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; + + if(Options.IsNot(ConstitutiveLaw::COMPUTE_STRESS)) + { + // COMPUTE_CONSTITUTIVE_TENSOR + Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); + Vector EffectiveStressVector(VoigtSize); + + this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,EffectiveStressVector,LinearElasticMatrix,rStrainVector); + + this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); + } + else + { + // COMPUTE_CONSTITUTIVE_TENSOR && COMPUTE_STRESS + Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); + Vector& rStressVector = rValues.GetStressVector(); + + this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); + + this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); + } + } + else if(Options.Is(ConstitutiveLaw::COMPUTE_STRESS)) + { + if(Options.Is(ConstitutiveLaw::MECHANICAL_RESPONSE_ONLY)) + { + // COMPUTE_STRESS: MECHANICAL COMPONENT + Vector& rStressVector = rValues.GetStressVector(); - // Initialize main variables // + // Total Strain + noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); + noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; - // LinearElasticMatrix - const double& YoungModulus = MaterialProperties[YOUNG_MODULUS]; - const double& PoissonCoefficient = MaterialProperties[POISSON_RATIO]; - const unsigned int VoigtSize = rStrainVector.size(); - Matrix LinearElasticMatrix (VoigtSize,VoigtSize); - this->CalculateLinearElasticMatrix(LinearElasticMatrix,YoungModulus,PoissonCoefficient); + this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); + } + else if(Options.Is(ConstitutiveLaw::THERMAL_RESPONSE_ONLY)) + { + // COMPUTE_STRESS : THEMAL COMPONENT + Vector& rStressVector = rValues.GetStressVector(); - // MaterialResponseVariables (Thermal variables) - HyperElastic3DLaw::MaterialResponseVariables ElasticVariables; - ElasticVariables.SetShapeFunctionsValues(rValues.GetShapeFunctionsValues()); - ElasticVariables.SetElementGeometry(rValues.GetElementGeometry()); - ElasticVariables.LameMu = 1.0+PoissonCoefficient; - ElasticVariables.ThermalExpansionCoefficient = MaterialProperties[THERMAL_EXPANSION]; - ElasticVariables.ReferenceTemperature = rValues.GetProcessInfo()[REFERENCE_TEMPERATURE]; - - // ReturnMappingVariables - FlowRule::RadialReturnVariables ReturnMappingVariables; - ReturnMappingVariables.initialize(); - // Strain and Stress matrices - const unsigned int Dim = this->WorkingSpaceDimension(); - Matrix AuxMatrix(Dim,Dim); - ReturnMappingVariables.StrainMatrix.resize(Dim,Dim,false); - ReturnMappingVariables.TrialIsoStressMatrix.resize(Dim,Dim,false); - // CharacteristicSize (for nonlocal damage it must be 1.0) - ReturnMappingVariables.CharacteristicSize = 1.0; + // Thermal strain + this->CalculateThermalStrain(rStrainVector,ElasticVariables); + noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); + noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; + + this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); + } + else // Compute total stress + { + // COMPUTE_STRESS : ALL STRESS COMPONENTS + Vector& rStressVector = rValues.GetStressVector(); - if(Options.Is(ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY)) // LOCAL QUANTITIES - { // Thermal strain Vector ThermalStrainVector(VoigtSize); this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables); @@ -104,121 +208,24 @@ void ThermalNonlocalDamage3DLaw::CalculateMaterialResponseCauchy (Parameters& rV noalias(rStrainVector) -= ThermalStrainVector; noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; - - if(Options.Is(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR)) //TOTAL STRESS - { - if(Options.IsNot(ConstitutiveLaw::COMPUTE_STRESS)) - { - // COMPUTE_CONSTITUTIVE_TENSOR - Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); - Vector EffectiveStressVector(VoigtSize); - - this->CalculateLocalReturnMapping(ReturnMappingVariables,AuxMatrix,EffectiveStressVector,LinearElasticMatrix,rStrainVector); - - this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); - } - else - { - // COMPUTE_CONSTITUTIVE_TENSOR && COMPUTE_STRESS - Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); - Vector& rStressVector = rValues.GetStressVector(); - - this->CalculateLocalReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); - - this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); - } - } - else if(Options.Is(ConstitutiveLaw::COMPUTE_STRESS)) //TOTAL STRESS - { - // COMPUTE_STRESS - Vector& rStressVector = rValues.GetStressVector(); - - this->CalculateLocalReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); - } + + this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); + } } - else // NONLOCAL QUANTITIES + else if(Options.Is(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN)) { - ReturnMappingVariables.NormIsochoricStress = mNonlocalEquivalentStrain; - - if(Options.Is(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR)) //TOTAL STRESS - { - // Thermal strain - Vector ThermalStrainVector(VoigtSize); - this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables); - // Mechanical strain - noalias(rStrainVector) -= ThermalStrainVector; - noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); - noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; - - if(Options.IsNot(ConstitutiveLaw::COMPUTE_STRESS)) - { - // COMPUTE_CONSTITUTIVE_TENSOR - Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); - Vector EffectiveStressVector(VoigtSize); - - this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,EffectiveStressVector,LinearElasticMatrix,rStrainVector); - - this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); - } - else - { - // COMPUTE_CONSTITUTIVE_TENSOR && COMPUTE_STRESS - Matrix& rConstitutiveMatrix = rValues.GetConstitutiveMatrix(); - Vector& rStressVector = rValues.GetStressVector(); - - this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); - - this->CalculateConstitutiveTensor(rConstitutiveMatrix, ReturnMappingVariables, LinearElasticMatrix); - } - } - else if(Options.Is(ConstitutiveLaw::COMPUTE_STRESS)) //TOTAL STRESS - { - // COMPUTE_STRESS - Vector& rStressVector = rValues.GetStressVector(); - - // Thermal strain - Vector ThermalStrainVector(VoigtSize); - this->CalculateThermalStrain(ThermalStrainVector,ElasticVariables); - // Mechanical strain - noalias(rStrainVector) -= ThermalStrainVector; - noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); - noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; - - this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); - } - else if(Options.Is(ConstitutiveLaw::TOTAL_TENSOR)) //This should be COMPUTE_MECHANICAL_STRESS - { - // COMPUTE_STRESS - Vector& rStressVector = rValues.GetStressVector(); - - // Total Strain - noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); - noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; - - this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); - } - else if(Options.Is(ConstitutiveLaw::VOLUMETRIC_TENSOR_ONLY)) //This should be COMPUTE_THERMAL_STRESS - { - // COMPUTE_STRESS - Vector& rStressVector = rValues.GetStressVector(); - - // Thermal strain - this->CalculateThermalStrain(rStrainVector,ElasticVariables); - noalias(AuxMatrix) = MathUtils::StrainVectorToTensor(rStrainVector); - noalias(ReturnMappingVariables.StrainMatrix) = AuxMatrix; - - this->CalculateReturnMapping(ReturnMappingVariables,AuxMatrix,rStressVector,LinearElasticMatrix,rStrainVector); - } - else if(Options.Is(ConstitutiveLaw::COMPUTE_STRAIN)) //This should be COMPUTE_THERMAL_STRAIN - { - // COMPUTE_STRAIN - - // Thermal strain - this->CalculateThermalStrain(rStrainVector,ElasticVariables); - } + // USE_ELEMENT_PROVIDED_STRAIN + if(Options.Is(ConstitutiveLaw::THERMAL_RESPONSE_ONLY)) + { + // Thermal strain + this->CalculateThermalStrain(rStrainVector,ElasticVariables); + } + //other strain: to implement } + } } + //---------------------------------------------------------------------------------------- void ThermalNonlocalDamage3DLaw::FinalizeMaterialResponseCauchy (Parameters& rValues) @@ -323,4 +330,4 @@ void ThermalNonlocalDamage3DLaw::CalculateThermalStrain(Vector& rThermalStrainVe KRATOS_CATCH( "" ) } -} // Namespace Kratos \ No newline at end of file +} // Namespace Kratos diff --git a/applications/DamApplication/custom_elements/small_displacement_thermo_mechanic_element.cpp b/applications/DamApplication/custom_elements/small_displacement_thermo_mechanic_element.cpp index e0dc95085621..53e949cc6f7e 100755 --- a/applications/DamApplication/custom_elements/small_displacement_thermo_mechanic_element.cpp +++ b/applications/DamApplication/custom_elements/small_displacement_thermo_mechanic_element.cpp @@ -55,7 +55,7 @@ void SmallDisplacementThermoMechanicElement::InitializeNonLinearIteration(Proces Flags &ConstitutiveLawOptions=Values.GetOptions(); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); - ConstitutiveLawOptions.Set(ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY); //Note: this is for nonlocal damage + ConstitutiveLawOptions.Set(ConstitutiveLaw::INITIALIZE_MATERIAL_RESPONSE); //Note: this is for nonlocal damage for ( unsigned int PointNumber = 0; PointNumber < mConstitutiveLawVector.size(); PointNumber++ ) { @@ -292,12 +292,17 @@ void SmallDisplacementThermoMechanicElement::CalculateOnIntegrationPoints(const //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - if( rVariable == CAUCHY_STRESS_VECTOR) - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); - else if(rVariable == THERMAL_STRESS_VECTOR) - ConstitutiveLawOptions.Set(ConstitutiveLaw::VOLUMETRIC_TENSOR_ONLY); - else if(rVariable == MECHANICAL_STRESS_VECTOR) - ConstitutiveLawOptions.Set(ConstitutiveLaw::TOTAL_TENSOR); + if( rVariable == CAUCHY_STRESS_VECTOR){ + ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); + } + else if(rVariable == THERMAL_STRESS_VECTOR){ + ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); + ConstitutiveLawOptions.Set(ConstitutiveLaw::THERMAL_RESPONSE_ONLY); + } + else if(rVariable == MECHANICAL_STRESS_VECTOR){ + ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); + ConstitutiveLawOptions.Set(ConstitutiveLaw::MECHANICAL_RESPONSE_ONLY); + } //reading integration points for ( unsigned int PointNumber = 0; PointNumber < mConstitutiveLawVector.size(); PointNumber++ ) @@ -329,8 +334,9 @@ void SmallDisplacementThermoMechanicElement::CalculateOnIntegrationPoints(const //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); - + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::THERMAL_RESPONSE_ONLY); + //reading integration points for ( unsigned int PointNumber = 0; PointNumber < mConstitutiveLawVector.size(); PointNumber++ ) { diff --git a/applications/DamApplication/custom_processes/bofang_condition_temperature_process.hpp b/applications/DamApplication/custom_processes/bofang_condition_temperature_process.hpp index ea3a7761d342..f24c83c1434e 100644 --- a/applications/DamApplication/custom_processes/bofang_condition_temperature_process.hpp +++ b/applications/DamApplication/custom_processes/bofang_condition_temperature_process.hpp @@ -63,7 +63,7 @@ class BofangConditionTemperatureProcess : public Process "Water_level_Table" : 0, "Outer_temp" : 0.0, "Outer_temp_Table" : 0, - "Month" : 1, + "Month" : 1.0, "Month_Table" : 0 } )" ); @@ -88,7 +88,7 @@ class BofangConditionTemperatureProcess : public Process mday = rParameters["Day_Ambient_Temp"].GetInt(); mwater_level = rParameters["Water_level"].GetDouble(); mouter_temp = rParameters["Outer_temp"].GetDouble(); - mmonth = rParameters["Month"].GetInt(); + mmonth = rParameters["Month"].GetDouble(); mfreq = 0.52323; mtime_unit_converter = mr_model_part.GetProcessInfo()[TIME_UNIT_CONVERTER]; @@ -271,7 +271,7 @@ class BofangConditionTemperatureProcess : public Process double mheight; double mamplitude; int mday; - int mmonth; + double mmonth; double mwater_level; double mouter_temp; double mfreq; diff --git a/applications/DamApplication/custom_python/dam_mpi_python_application.cpp b/applications/DamApplication/custom_python/dam_mpi_python_application.cpp index 77e21599827c..2e5d602588ed 100644 --- a/applications/DamApplication/custom_python/dam_mpi_python_application.cpp +++ b/applications/DamApplication/custom_python/dam_mpi_python_application.cpp @@ -42,17 +42,8 @@ BOOST_PYTHON_MODULE(KratosDamApplication) AddCustomUtilitiesToPython(); //Registering variables in python - - //Bofang and Hidrostatic variables for evolution changes - KRATOS_REGISTER_IN_PYTHON_VARIABLE( GRAVITY_DIRECTION ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( COORDINATE_BASE_DAM ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( SURFACE_TEMP ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( BOTTOM_TEMP ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( HEIGHT_DAM ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( AMPLITUDE ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( DAY_MAXIMUM ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( SPECIFIC_WEIGHT ) - + KRATOS_REGISTER_IN_PYTHON_VARIABLE( THERMAL_EXPANSION ) + // Thermal Variables KRATOS_REGISTER_IN_PYTHON_VARIABLE( THERMAL_STRESS_TENSOR ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( MECHANICAL_STRESS_TENSOR ) @@ -75,6 +66,8 @@ BOOST_PYTHON_MODULE(KratosDamApplication) KRATOS_REGISTER_IN_PYTHON_VARIABLE( ACCELERATION_PRESSURE_COEFFICIENT ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( NODAL_YOUNG_MODULUS ) + KRATOS_REGISTER_IN_PYTHON_VARIABLE( ADDED_MASS ) + } diff --git a/applications/DamApplication/custom_python/dam_python_application.cpp b/applications/DamApplication/custom_python/dam_python_application.cpp index 8b62ebcae731..f1827e1d068e 100755 --- a/applications/DamApplication/custom_python/dam_python_application.cpp +++ b/applications/DamApplication/custom_python/dam_python_application.cpp @@ -40,17 +40,8 @@ BOOST_PYTHON_MODULE(KratosDamApplication) AddCustomUtilitiesToPython(); //Registering variables in python - - //Bofang and Hidrostatic variables for evolution changes - KRATOS_REGISTER_IN_PYTHON_VARIABLE( GRAVITY_DIRECTION ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( COORDINATE_BASE_DAM ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( SURFACE_TEMP ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( BOTTOM_TEMP ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( HEIGHT_DAM ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( AMPLITUDE ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( DAY_MAXIMUM ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( SPECIFIC_WEIGHT ) - + KRATOS_REGISTER_IN_PYTHON_VARIABLE( THERMAL_EXPANSION ) + // Thermal Variables KRATOS_REGISTER_IN_PYTHON_VARIABLE( THERMAL_STRESS_TENSOR ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( MECHANICAL_STRESS_TENSOR ) @@ -72,7 +63,9 @@ BOOST_PYTHON_MODULE(KratosDamApplication) KRATOS_REGISTER_IN_PYTHON_VARIABLE( VELOCITY_PRESSURE_COEFFICIENT ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( ACCELERATION_PRESSURE_COEFFICIENT ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( NODAL_YOUNG_MODULUS ) + KRATOS_REGISTER_IN_PYTHON_VARIABLE( NODAL_YOUNG_MODULUS ) + KRATOS_REGISTER_IN_PYTHON_VARIABLE( ADDED_MASS ) + } } // namespace Python. diff --git a/applications/DamApplication/dam_application.cpp b/applications/DamApplication/dam_application.cpp index 803315d6fd89..f44c6235d99f 100755 --- a/applications/DamApplication/dam_application.cpp +++ b/applications/DamApplication/dam_application.cpp @@ -153,20 +153,7 @@ void KratosDamApplication::Register() //Register Variables KRATOS_REGISTER_VARIABLE( THERMAL_EXPANSION ) - - //Bofang, Hidrostatic and uplift variables for evolution changes - KRATOS_REGISTER_VARIABLE( GRAVITY_DIRECTION ) - KRATOS_REGISTER_VARIABLE( COORDINATE_BASE_DAM ) - KRATOS_REGISTER_VARIABLE( SURFACE_TEMP ) - KRATOS_REGISTER_VARIABLE( BOTTOM_TEMP ) - KRATOS_REGISTER_VARIABLE( HEIGHT_DAM ) - KRATOS_REGISTER_VARIABLE( AMPLITUDE ) - KRATOS_REGISTER_VARIABLE( DAY_MAXIMUM ) - KRATOS_REGISTER_VARIABLE( SPECIFIC_WEIGHT ) - KRATOS_REGISTER_VARIABLE( UPLIFT_DIRECTION ) - KRATOS_REGISTER_VARIABLE( COORDINATE_BASE_DAM_UPLIFT ) - KRATOS_REGISTER_VARIABLE( BASE_OF_DAM ) - + // Thermal Variables KRATOS_REGISTER_VARIABLE( THERMAL_STRESS_TENSOR ) KRATOS_REGISTER_VARIABLE( MECHANICAL_STRESS_TENSOR ) diff --git a/applications/DamApplication/dam_application_variables.cpp b/applications/DamApplication/dam_application_variables.cpp index f8f258521231..0f9c4627c2a9 100644 --- a/applications/DamApplication/dam_application_variables.cpp +++ b/applications/DamApplication/dam_application_variables.cpp @@ -13,19 +13,6 @@ namespace Kratos //Create Variables //Note that the application variables must not be defined if they already exist in KRATOS KRATOS_CREATE_VARIABLE( double, THERMAL_EXPANSION ) - - //Bofang, Hidrostatic and uplift variables for evolution changes - KRATOS_CREATE_VARIABLE( std::string, GRAVITY_DIRECTION ) - KRATOS_CREATE_VARIABLE( double, COORDINATE_BASE_DAM ) - KRATOS_CREATE_VARIABLE( double, SURFACE_TEMP ) - KRATOS_CREATE_VARIABLE( double, BOTTOM_TEMP ) - KRATOS_CREATE_VARIABLE( double, HEIGHT_DAM ) - KRATOS_CREATE_VARIABLE( double, AMPLITUDE ) - KRATOS_CREATE_VARIABLE( double, DAY_MAXIMUM ) - KRATOS_CREATE_VARIABLE( double, SPECIFIC_WEIGHT ) - KRATOS_CREATE_VARIABLE( std::string, UPLIFT_DIRECTION ) - KRATOS_CREATE_VARIABLE( double, COORDINATE_BASE_DAM_UPLIFT ) - KRATOS_CREATE_VARIABLE( double, BASE_OF_DAM ) // Thermal Variables KRATOS_CREATE_VARIABLE( Matrix, THERMAL_STRESS_TENSOR ) diff --git a/applications/DamApplication/dam_application_variables.h b/applications/DamApplication/dam_application_variables.h index ae50ba6f9a42..f55259e51cbc 100644 --- a/applications/DamApplication/dam_application_variables.h +++ b/applications/DamApplication/dam_application_variables.h @@ -23,19 +23,6 @@ namespace Kratos //Define Variables KRATOS_DEFINE_VARIABLE( double, THERMAL_EXPANSION ) - //Bofang, Hidrostatic and uplift variables for evolution changes - KRATOS_DEFINE_VARIABLE( std::string, GRAVITY_DIRECTION ) - KRATOS_DEFINE_VARIABLE( double, COORDINATE_BASE_DAM ) - KRATOS_DEFINE_VARIABLE( double, SURFACE_TEMP ) - KRATOS_DEFINE_VARIABLE( double, BOTTOM_TEMP ) - KRATOS_DEFINE_VARIABLE( double, HEIGHT_DAM ) - KRATOS_DEFINE_VARIABLE( double, AMPLITUDE ) - KRATOS_DEFINE_VARIABLE( double, DAY_MAXIMUM ) - KRATOS_DEFINE_VARIABLE( double, SPECIFIC_WEIGHT ) - KRATOS_DEFINE_VARIABLE( std::string, UPLIFT_DIRECTION ) - KRATOS_DEFINE_VARIABLE( double, COORDINATE_BASE_DAM_UPLIFT ) - KRATOS_DEFINE_VARIABLE( double, BASE_OF_DAM ) - // Thermal Variables KRATOS_DEFINE_VARIABLE( Matrix, THERMAL_STRESS_TENSOR ) KRATOS_DEFINE_VARIABLE( Matrix, MECHANICAL_STRESS_TENSOR ) diff --git a/applications/DamApplication/python_scripts/dam_MPI_thermo_mechanic_solver.py b/applications/DamApplication/python_scripts/dam_MPI_thermo_mechanic_solver.py index 9a5988cddc35..7187860995ee 100644 --- a/applications/DamApplication/python_scripts/dam_MPI_thermo_mechanic_solver.py +++ b/applications/DamApplication/python_scripts/dam_MPI_thermo_mechanic_solver.py @@ -277,4 +277,4 @@ def _ConstructSolver(self, builder_and_solver, scheme, convergence_criterion, st else: raise Exception("Apart from Newton-Raphson, other strategy_type are not available.") - return solver \ No newline at end of file + return solver diff --git a/applications/DamApplication/test_examples/2d_dam_nonlocaldamage_with_reservoir_thermomechanical.gid/ProjectParameters.json b/applications/DamApplication/test_examples/2d_dam_nonlocaldamage_with_reservoir_thermomechanical.gid/ProjectParameters.json index ad17df649f5a..35e4bbcc1d3e 100644 --- a/applications/DamApplication/test_examples/2d_dam_nonlocaldamage_with_reservoir_thermomechanical.gid/ProjectParameters.json +++ b/applications/DamApplication/test_examples/2d_dam_nonlocaldamage_with_reservoir_thermomechanical.gid/ProjectParameters.json @@ -162,7 +162,7 @@ "Water_level_Table" : 0, "Outer_temp" : 5.0, "Outer_temp_Table" : 0, - "Month" : 6, + "Month" : 6.0, "Month_Table" : 0 } }], diff --git a/applications/DamApplication/test_examples/2d_dam_thermo_mechanical.gid/ProjectParameters.json b/applications/DamApplication/test_examples/2d_dam_thermo_mechanical.gid/ProjectParameters.json index 877c678e266e..e2f16db45b78 100644 --- a/applications/DamApplication/test_examples/2d_dam_thermo_mechanical.gid/ProjectParameters.json +++ b/applications/DamApplication/test_examples/2d_dam_thermo_mechanical.gid/ProjectParameters.json @@ -147,7 +147,7 @@ "Water_level_Table" : 1, "Outer_temp" : 5, "Outer_temp_Table" : 2, - "Month" : 1, + "Month" : 1.0, "Month_Table" : 3 } }], diff --git a/applications/DamApplication/test_examples/2d_dam_thermo_mechanical.gid/meses.csv b/applications/DamApplication/test_examples/2d_dam_thermo_mechanical.gid/meses.csv index b784eb73496b..92c213f3131d 100644 --- a/applications/DamApplication/test_examples/2d_dam_thermo_mechanical.gid/meses.csv +++ b/applications/DamApplication/test_examples/2d_dam_thermo_mechanical.gid/meses.csv @@ -1,14 +1,14 @@ -0.0 1 -1.0 1 -2.0 2 -3.0 3 -4.0 4 -5.0 5 -6.0 6 -7.0 7 -8.0 8 -9.0 9 -10.0 10 -11.0 11 -12.0 12 +0.0 1.0 +1.0 1.0 +2.0 2.0 +3.0 3.0 +4.0 4.0 +5.0 5.0 +6.0 6.0 +7.0 7.0 +8.0 8.0 +9.0 9.0 +10.0 10.0 +11.0 11.0 +12.0 12.0 diff --git a/applications/FSIapplication/CMakeLists.txt b/applications/FSIapplication/CMakeLists.txt index 9cacb22fb8e2..ce6840feaf94 100644 --- a/applications/FSIapplication/CMakeLists.txt +++ b/applications/FSIapplication/CMakeLists.txt @@ -14,6 +14,7 @@ set( KRATOS_FSI_APPLICATION_SOURCES ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_convergence_accelerators_to_python.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_utilities/AdvancedNMPointsMapper.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_utilities/variable_redistribution_utility.cpp ) ############################################################### diff --git a/applications/FSIapplication/custom_python/add_custom_utilities_to_python.cpp b/applications/FSIapplication/custom_python/add_custom_utilities_to_python.cpp index a58072493632..4dcc5b89405a 100644 --- a/applications/FSIapplication/custom_python/add_custom_utilities_to_python.cpp +++ b/applications/FSIapplication/custom_python/add_custom_utilities_to_python.cpp @@ -21,6 +21,7 @@ #include "custom_utilities/FSI_utils.h" #include "custom_utilities/aitken_utils.h" #include "custom_utilities/partitioned_fsi_utilities.hpp" +#include "custom_utilities/variable_redistribution_utility.h" namespace Kratos { @@ -62,6 +63,25 @@ void AddCustomUtilitiesToPython() .def("ComputeFluidInterfaceMeshVelocityResidualNorm",&PartitionedFSIUtilities::ComputeFluidInterfaceMeshVelocityResidualNorm) ; + typedef void (*DistributePointDoubleType)(ModelPart&, const Variable< double >&, const Variable< double >&, double, unsigned int); + typedef void (*DistributePointArrayType)(ModelPart&, const Variable< array_1d >&, const Variable< array_1d >&,double, unsigned int); + + DistributePointDoubleType DistributePointDouble = &VariableRedistributionUtility::DistributePointValues; + DistributePointArrayType DistributePointArray = &VariableRedistributionUtility::DistributePointValues; + + typedef void (*ConvertDistributedDoubleType)(ModelPart&, const Variable< double >&, const Variable< double >&); + typedef void (*ConvertDistributedArrayType)(ModelPart&, const Variable< array_1d >&, const Variable< array_1d >&); + + ConvertDistributedDoubleType ConvertDistributedDouble = &VariableRedistributionUtility::ConvertDistributedValuesToPoint; + ConvertDistributedArrayType ConvertDistributedArray = &VariableRedistributionUtility::ConvertDistributedValuesToPoint; + + // Note: The StaticMethod thing should be done only once for each set of overloads + class_< VariableRedistributionUtility, boost::noncopyable >("VariableRedistributionUtility", no_init) + .def("DistributePointValues",DistributePointDouble) + .def("DistributePointValues",DistributePointArray).staticmethod("DistributePointValues") + .def("ConvertDistributedValuesToPoint",ConvertDistributedDouble) + .def("ConvertDistributedValuesToPoint",ConvertDistributedArray).staticmethod("ConvertDistributedValuesToPoint") + ; } } // namespace Python. diff --git a/applications/FSIapplication/custom_utilities/AdvancedNMPointsMapper.cpp b/applications/FSIapplication/custom_utilities/AdvancedNMPointsMapper.cpp index a2226b379791..d03d2abe8baa 100644 --- a/applications/FSIapplication/custom_utilities/AdvancedNMPointsMapper.cpp +++ b/applications/FSIapplication/custom_utilities/AdvancedNMPointsMapper.cpp @@ -115,11 +115,12 @@ void GaussPointItem::GetProjectedValue(const Variable & rOriginVar, double& Value) { Value = 0.0; // Value initialization (if mProjStatus == 2 it will remain as 0.0) - GeometryType& rOriginGeom = (mpOriginCond.lock())->GetGeometry(); - const unsigned int dimension = rOriginGeom.WorkingSpaceDimension(); if (mProjStatus == 1) // Get Interpolated value from origin condition { + GeometryType& rOriginGeom = (mpOriginCond.lock())->GetGeometry(); + const unsigned int dimension = rOriginGeom.WorkingSpaceDimension(); + // Shape functions values in the projected Gauss pt. Point<3> GPloccoords = (dimension == 2) ? Point(mOriginCoords[0], 0.0, 0.0) : Point(mOriginCoords[0], mOriginCoords[1], 0.0); Vector shfunc_values; @@ -1479,8 +1480,7 @@ void AdvancedNMPointsMapper::VectorMap(const Variable >& rOri const Variable >& rDestVar, const int MaxIter, const double TolIter, - const bool sign_pos, - const bool distributed) + const bool sign_pos) { const unsigned int dimension = mrDestinationModelPart.ConditionsBegin()->GetGeometry().WorkingSpaceDimension(); @@ -1493,18 +1493,6 @@ void AdvancedNMPointsMapper::VectorMap(const Variable >& rOri // Compute nodal lengths/areas (NODAL_MAUX) in both origin and destination modelparts ComputeNodalLengthArea(); - // If dealing with punctual loads, obtain their equivalent tractions - if (distributed == true) - { - int MaxIterTractions = MaxIter; - double TolIterTractions = TolIter; - ComputeEquivalentTractions(rOriginVar, MaxIterTractions, TolIterTractions); - } - - // If distributed, set VAUX_EQ_TRACTION as origin and destination variable - Variable> AuxDestVar = (distributed == false) ? rDestVar : VAUX_EQ_TRACTION; - Variable> AuxOriginVar = (distributed == false) ? rOriginVar : VAUX_EQ_TRACTION; - if (dimension == 2) // 2D case { // Interpolation matrix obtention @@ -1551,7 +1539,7 @@ void AdvancedNMPointsMapper::VectorMap(const Variable >& rOri // Get the Gauss pts. values for (unsigned int i=0; iGetProjectedValue(AuxOriginVar, TempValues); + mGaussPointList[GPi + i]->GetProjectedValue(rOriginVar, TempValues); for (unsigned int j = 0; j < 3; j++) { GPValues[3*i + j] = TempValues[j]; @@ -1601,8 +1589,8 @@ void AdvancedNMPointsMapper::VectorMap(const Variable >& rOri for(unsigned int j = 0; j < 3; j++) { - LastSolution[j] = sign * rGeom[0].FastGetSolutionStepValue(AuxDestVar)[j]; - LastSolution[3 + j] = sign * rGeom[1].FastGetSolutionStepValue(AuxDestVar)[j]; + LastSolution[j] = sign * rGeom[0].FastGetSolutionStepValue(rDestVar)[j]; + LastSolution[3 + j] = sign * rGeom[1].FastGetSolutionStepValue(rDestVar)[j]; } array_1d CondValues = *pInterpValues[IV_iter]; @@ -1632,7 +1620,7 @@ void AdvancedNMPointsMapper::VectorMap(const Variable >& rOri ModelPart::NodeIterator node_it = mrDestinationModelPart.NodesBegin() + i; const double & NodeLength = node_it->GetValue(NODAL_MAUX); noalias(dVal) = node_it->GetValue(MAPPER_VECTOR_PROJECTION_RHS)/NodeLength; - array_1d& rDestinationValue = node_it->FastGetSolutionStepValue(AuxDestVar); + array_1d& rDestinationValue = node_it->FastGetSolutionStepValue(rDestVar); rDestinationValue += sign * dVal; // Variables for convergence check @@ -1679,13 +1667,10 @@ void AdvancedNMPointsMapper::VectorMap(const Variable >& rOri array_1d TempValues = ZeroVector(3); - // If distributed, set VAUX_EQ_TRACTION as origin variable - Variable> AuxOriginVar = (distributed == false) ? rOriginVar : VAUX_EQ_TRACTION; - // Get the Gauss pts. values for (unsigned int i=0; iGetProjectedValue(AuxOriginVar, TempValues); + mGaussPointList[GPi + i]->GetProjectedValue(rOriginVar, TempValues); for (unsigned int j = 0; j < 3; j++) { GPValues[3*i + j] = TempValues[j]; @@ -1736,9 +1721,9 @@ void AdvancedNMPointsMapper::VectorMap(const Variable >& rOri for(unsigned int j = 0; j < 3; j++) { - LastSolution[j] = sign * rGeom[0].FastGetSolutionStepValue(AuxDestVar)[j]; - LastSolution[3 + j] = sign * rGeom[1].FastGetSolutionStepValue(AuxDestVar)[j]; - LastSolution[6 + j] = sign * rGeom[2].FastGetSolutionStepValue(AuxDestVar)[j]; + LastSolution[j] = sign * rGeom[0].FastGetSolutionStepValue(rDestVar)[j]; + LastSolution[3 + j] = sign * rGeom[1].FastGetSolutionStepValue(rDestVar)[j]; + LastSolution[6 + j] = sign * rGeom[2].FastGetSolutionStepValue(rDestVar)[j]; } array_1d CondValues = *pInterpValues[IV_iter]; @@ -1770,7 +1755,7 @@ void AdvancedNMPointsMapper::VectorMap(const Variable >& rOri ModelPart::NodeIterator node_it = mrDestinationModelPart.NodesBegin() + i; const double & NodeArea = node_it->GetValue(NODAL_MAUX); noalias(dVal) = node_it->GetValue(MAPPER_VECTOR_PROJECTION_RHS)/NodeArea; - array_1d& rDestinationValue = node_it->FastGetSolutionStepValue(AuxDestVar); + array_1d& rDestinationValue = node_it->FastGetSolutionStepValue(rDestVar); rDestinationValue += sign * dVal; // Variables for convergence check @@ -1797,13 +1782,6 @@ void AdvancedNMPointsMapper::VectorMap(const Variable >& rOri } // End of Iteration } - - // Convert the computed equivalent tractions to punctual nodal loads - if (distributed == true) - { - ComputeNodalLoadsFromTractions(rDestVar); - } - } // End of Map (vector version) /** @@ -1943,354 +1921,4 @@ void AdvancedNMPointsMapper::ComputeNodalLengthArea() } } -/** - * Auxiliar function to compute the equivalent nodal tractions to point loads minimizing the L2 norm of the error. - * @param rOriginVar: Origin variable to be converted to tractions - * @param MaxIter: Maximum iterations - * @param TolIter: Absolute tolerance - */ -void AdvancedNMPointsMapper::ComputeEquivalentTractions(const Variable >& rOriginVar, - const int MaxIter, - const double TolIter) -{ - const unsigned int dimension = mrOriginModelPart.ConditionsBegin()->GetGeometry().WorkingSpaceDimension(); - - // Initialization of equivalent tractions - VariableUtils().SetToZero_VectorVar(VAUX_EQ_TRACTION, mrOriginModelPart.Nodes()); - - if (dimension == 2) - { - - boost::numeric::ublas::bounded_matrix MassMat; // Elemental consistent mass matrix 2 Gauss points in a 1D element - - MassMat(0, 0) = 2.0/3.0; MassMat(0, 1) = 1.0/3.0; - MassMat(1, 0) = 1.0/3.0; MassMat(1, 1) = 2.0/3.0; - - // Store the initial guess - #pragma omp parallel for - for (int i=0; i(mrOriginModelPart.NumberOfNodes()); ++i) - { - ModelPart::NodesContainerType::const_iterator node_it = mrOriginModelPart.NodesBegin() + i; - for(unsigned int j = 0; j < 2; j++) - { - const double NodeLength = node_it->GetValue(NODAL_MAUX); - node_it->FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j] = (node_it->FastGetSolutionStepValue(rOriginVar)[j])/NodeLength; - } - } - - // Iteration - for (int k = 0; k < MaxIter; k++) - { - // At the begining of each iteration initialize the variable containing the assembled RHS as 0 - #pragma omp parallel for - for (int i=0; i(mrOriginModelPart.NumberOfNodes()); ++i) - { - ModelPart::NodesContainerType::const_iterator node_it = mrOriginModelPart.NodesBegin() + i; - node_it->SetValue(MAPPER_VECTOR_PROJECTION_RHS, ZeroVector(3)); - } - - array_1d LocalRHS0, LocalRHS1; // Local RHS for each node - array_1d LastSolution; - array_1d OriginNodalValues; - - for(ModelPart::ConditionsContainerType::const_iterator cond_it = mrOriginModelPart.ConditionsBegin(); - cond_it != mrOriginModelPart.ConditionsEnd(); - cond_it++) - { - - double CondLength = 0.0; - CondLength = cond_it->GetGeometry().Length(); - const double Jac = 0.5*CondLength; - - LocalRHS0 = ZeroVector(3); - LocalRHS1 = ZeroVector(3); - OriginNodalValues = ZeroVector(6); - - // Original nodal values (assembled) - for(unsigned int j = 0; j < 3; j++) - { - OriginNodalValues[j] = cond_it->GetGeometry()[0].FastGetSolutionStepValue(rOriginVar)[j]; - OriginNodalValues[3 + j] = cond_it->GetGeometry()[1].FastGetSolutionStepValue(rOriginVar)[j]; - } - - // Unassemble the nodal values to obtain their elemental contributions - double aux0 = Jac/(cond_it->GetGeometry()[0].GetValue(NODAL_MAUX)); - double aux1 = Jac/(cond_it->GetGeometry()[1].GetValue(NODAL_MAUX)); - - for(unsigned int j = 0; j < 3; j++) - { - OriginNodalValues[j] *= aux0; - OriginNodalValues[3 + j] *= aux1; - } - - // Previous iteration solution - for(unsigned int j = 0; j < 3; j++) - { - LastSolution[j] = cond_it->GetGeometry()[0].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - LastSolution[3 + j] = cond_it->GetGeometry()[1].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - } - - // Compute the nodal RHS - for(unsigned int j = 0; j < 3; j++) - { - LocalRHS0[j] = OriginNodalValues[j] - Jac * (MassMat(0,0)*LastSolution[j] + MassMat(0,1)*LastSolution[j + 3]); - LocalRHS1[j] = OriginNodalValues[j + 3] - Jac * (MassMat(1,0)*LastSolution[j] + MassMat(1,1)*LastSolution[j + 3]); - } - - // Accumulate the nodal RHS (localRHS) - cond_it->GetGeometry()[0].GetValue(MAPPER_VECTOR_PROJECTION_RHS) += LocalRHS0; - cond_it->GetGeometry()[1].GetValue(MAPPER_VECTOR_PROJECTION_RHS) += LocalRHS1; - } - - // Solve - array_1d dVal = ZeroVector(3); - double dValNorm = 0.0; - double ValNorm = 0.0; - const unsigned int NodeNum = mrOriginModelPart.NumberOfNodes(); - - #pragma omp parallel for reduction(+ : dValNorm, ValNorm) private(dVal) - for (int i=0; i(mrOriginModelPart.NumberOfNodes()); ++i) - { - ModelPart::NodesContainerType::const_iterator node_it = mrOriginModelPart.NodesBegin() + i; - const double NodeLength = node_it->GetValue(NODAL_MAUX); - noalias(dVal) = node_it->GetValue(MAPPER_VECTOR_PROJECTION_RHS)/NodeLength; - array_1d& rEquivalentTraction = node_it->FastGetSolutionStepValue(VAUX_EQ_TRACTION); - rEquivalentTraction += dVal; - - // Variables for convergence check - for (unsigned int j = 0; j < 3; j++) - { - dValNorm += dVal[j] * dVal[j]; - ValNorm += rEquivalentTraction[j]*rEquivalentTraction[j]; - } - } - - // std::cout << "Compute equivalent tractions iteration: " << k+1 << " dValNorm " << dValNorm << std::endl; - - // Check Convergence - const double RelativeError = (ValNorm > 10e-15) ? dValNorm / ValNorm : 0.0; - if( (ValNorm/NodeNum < 0.00001 * TolIter * TolIter) || RelativeError < TolIter * TolIter) - { - std::cout << "ComputeEquivalentTractions converged in " << k + 1 << " iterations." << std::endl; - break; - } - else if ( (k + 1) == MaxIter) - { - std::cout << "WARNING: ComputeEquivalentTractions did not converge in " << k + 1 << " iterations." << std::endl; - } - } // End of Iteration - } - else - { - boost::numeric::ublas::bounded_matrix MassMat; // Elemental consistent mass matrix 3 Gauss points in a 2D triangular element - - MassMat(0, 0) = 1.0/12.0; MassMat(0, 1) = 1.0/24.0; MassMat(0, 2) = 1.0/24.0; - MassMat(1, 0) = 1.0/24.0; MassMat(1, 1) = 1.0/12.0; MassMat(1, 2) = 1.0/24.0; - MassMat(2, 0) = 1.0/24.0; MassMat(2, 1) = 1.0/24.0; MassMat(2, 2) = 1.0/12.0; - - // Store the initial guess - #pragma omp parallel for - for (int i=0; i(mrOriginModelPart.NumberOfNodes()); ++i) - { - ModelPart::NodesContainerType::const_iterator node_it = mrOriginModelPart.NodesBegin() + i; - for(unsigned int j = 0; j < 3; j++) - { - const double & NodeArea = node_it->GetValue(NODAL_MAUX); - node_it->FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j] = (node_it->FastGetSolutionStepValue(rOriginVar)[j])/NodeArea; - } - } - - // Iteration - for (int k = 0; k < MaxIter; k++) - { - // At the begining of each iteration initialize the variable containing the assembled RHS as 0 - #pragma omp parallel for - for (int i=0; i(mrOriginModelPart.NumberOfNodes()); ++i) - { - ModelPart::NodesContainerType::const_iterator node_it = mrOriginModelPart.NodesBegin() + i; - node_it->SetValue(MAPPER_VECTOR_PROJECTION_RHS, ZeroVector(3)); - } - - array_1d LocalRHS0, LocalRHS1, LocalRHS2; // Local RHS for each node - array_1d LastSolution; - array_1d OriginNodalValues; - - for(ModelPart::ConditionsContainerType::const_iterator cond_it = mrOriginModelPart.ConditionsBegin(); - cond_it != mrOriginModelPart.ConditionsEnd(); - cond_it++) - { - GeometryType& rGeom = cond_it->GetGeometry(); - const double CondArea = rGeom.Area(); - const double Jac = 2.0*CondArea; - - LocalRHS0 = ZeroVector(3); - LocalRHS1 = ZeroVector(3); - LocalRHS2 = ZeroVector(3); - OriginNodalValues = ZeroVector(9); - - // Original nodal values (unassemble the nodal values to obtain their elemental contributions) - for(unsigned int j = 0; j < 3; j++) - { - OriginNodalValues[j] = rGeom[0].FastGetSolutionStepValue(rOriginVar)[j]*(CondArea/3.0)/(rGeom[0].GetValue(NODAL_MAUX)); - OriginNodalValues[3 + j] = rGeom[1].FastGetSolutionStepValue(rOriginVar)[j]*(CondArea/3.0)/(rGeom[1].GetValue(NODAL_MAUX)); - OriginNodalValues[6 + j] = rGeom[2].FastGetSolutionStepValue(rOriginVar)[j]*(CondArea/3.0)/(rGeom[2].GetValue(NODAL_MAUX)); - } - - // Previous iteration solution - for(unsigned int j = 0; j < 3; j++) - { - LastSolution[j] = rGeom[0].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - LastSolution[3 + j] = rGeom[1].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - LastSolution[6 + j] = rGeom[2].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - } - - // Compute the nodal RHS - for(unsigned int j = 0; j < 3; j++) - { - LocalRHS0[j] = OriginNodalValues[j] - Jac * (MassMat(0,0)*LastSolution[j] + MassMat(0,1)*LastSolution[j + 3] + MassMat(0,2)*LastSolution[j + 6]); - LocalRHS1[j] = OriginNodalValues[j + 3] - Jac * (MassMat(1,0)*LastSolution[j] + MassMat(1,1)*LastSolution[j + 3] + MassMat(1,2)*LastSolution[j + 6]); - LocalRHS2[j] = OriginNodalValues[j + 6] - Jac * (MassMat(2,0)*LastSolution[j] + MassMat(2,1)*LastSolution[j + 3] + MassMat(2,2)*LastSolution[j + 6]); - } - - // Accumulate the nodal RHS (localRHS) - rGeom[0].GetValue(MAPPER_VECTOR_PROJECTION_RHS) += LocalRHS0; - rGeom[1].GetValue(MAPPER_VECTOR_PROJECTION_RHS) += LocalRHS1; - rGeom[2].GetValue(MAPPER_VECTOR_PROJECTION_RHS) += LocalRHS2; - } - - // Solve - array_1d dVal = ZeroVector(3); - double dValNorm = 0.0; - double ValNorm = 0.0; - const unsigned int NodeNum = mrOriginModelPart.NumberOfNodes(); - - #pragma omp parallel for reduction(+ : dValNorm, ValNorm) private(dVal) - for (int i=0; i(mrOriginModelPart.NumberOfNodes()); ++i) - { - ModelPart::NodesContainerType::const_iterator node_it = mrOriginModelPart.NodesBegin() + i; - const double NodeArea = node_it->GetValue(NODAL_MAUX); - noalias(dVal) = node_it->GetValue(MAPPER_VECTOR_PROJECTION_RHS)/NodeArea; - node_it->FastGetSolutionStepValue(VAUX_EQ_TRACTION) += dVal; - - // Variables for convergence check - for (unsigned int j = 0; j < 3; j++) - { - dValNorm += dVal[j] * dVal[j]; - ValNorm += std::pow(node_it->FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j], 2); - } - } - - //~ std::cout << "Compute equivalent tractions iteration: " << k+1 << " dValNorm " << dValNorm << std::endl; - - // Check Convergence - const double RelativeError = (ValNorm > 10e-15) ? dValNorm / ValNorm : 0.0; - if( (ValNorm/NodeNum < 0.00001 * TolIter * TolIter) || RelativeError < TolIter * TolIter) - { - std::cout << "Compute equivalent tractions converged in " << k + 1 << " iterations." << std::endl; - break; - } - else if ( (k + 1) == MaxIter) - { - std::cout << "WARNING: Compute equivalent tractions did not converge in " << k + 1 << " iterations." << std::endl; - } - } // End of Iteration - } -} - -/** - * Auxiliar function to recover punctual loads from equivalent tractions. - * @param rOriginVar: Destination variable to store the recovered nodal values - */ -void AdvancedNMPointsMapper::ComputeNodalLoadsFromTractions(const Variable >& rDestVar) -{ - const unsigned int dimension = mrDestinationModelPart.ConditionsBegin()->GetGeometry().WorkingSpaceDimension(); - - if (dimension == 2) - { - - boost::numeric::ublas::bounded_matrix MassMat; // Elemental consistent mass matrix 2 Gauss points in a 1D element - MassMat(0, 0) = 2.0/3.0; MassMat(0, 1) = 1.0/3.0; - MassMat(1, 0) = 1.0/3.0; MassMat(1, 1) = 2.0/3.0; - - array_1d Node0Values; - array_1d Node1Values; - array_1d NodalTractions; - - for(ModelPart::ConditionsContainerType::const_iterator cond_it = mrDestinationModelPart.ConditionsBegin(); - cond_it != mrDestinationModelPart.ConditionsEnd(); - cond_it++) - { - GeometryType& rGeom = cond_it->GetGeometry(); - const double Jac = 0.5*rGeom.Length(); - - Node0Values = ZeroVector(3); - Node1Values = ZeroVector(3); - NodalTractions = ZeroVector(6); - - for(unsigned int j = 0; j < 3; j++) - { - NodalTractions[j] = rGeom[0].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - NodalTractions[3 + j] = rGeom[1].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - } - - for(unsigned int j = 0; j < 3; j++) - { - Node0Values[j] = Jac*(MassMat(0,0)*NodalTractions[j]+MassMat(0,1)*NodalTractions[j+3]); - Node1Values[j] = Jac*(MassMat(1,0)*NodalTractions[j]+MassMat(1,1)*NodalTractions[j+3]); - } - - // We are taking advantage of 1 Condition = 2 Gauss Points to iterate the interpolation results and the Gauss Point Vector Again - rGeom[0].FastGetSolutionStepValue(rDestVar) += Node0Values; - rGeom[1].FastGetSolutionStepValue(rDestVar) += Node1Values; - } - } - else - { - boost::numeric::ublas::bounded_matrix MassMat; // Elemental consistent mass matrix 3 Gauss points in a 2D triangular element - MassMat(0, 0) = 1.0/12.0; MassMat(0, 1) = 1.0/24.0; MassMat(0, 2) = 1.0/24.0; - MassMat(1, 0) = 1.0/24.0; MassMat(1, 1) = 1.0/12.0; MassMat(1, 2) = 1.0/24.0; - MassMat(2, 0) = 1.0/24.0; MassMat(2, 1) = 1.0/24.0; MassMat(2, 2) = 1.0/12.0; - - array_1d Node0Values; - array_1d Node1Values; - array_1d Node2Values; - array_1d NodalTractions; - int IV_iter = 0; - - for(ModelPart::ConditionsContainerType::const_iterator cond_it = mrDestinationModelPart.ConditionsBegin(); - cond_it != mrDestinationModelPart.ConditionsEnd(); - cond_it++) - { - GeometryType& rGeom = cond_it->GetGeometry(); - const double Jac = 2.0*rGeom.Area(); - - Node0Values = ZeroVector(3); - Node1Values = ZeroVector(3); - Node2Values = ZeroVector(3); - NodalTractions = ZeroVector(9); - - for(unsigned int j = 0; j < 3; j++) - { - NodalTractions[j] = rGeom[0].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - NodalTractions[3 + j] = rGeom[1].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - NodalTractions[6 + j] = rGeom[2].FastGetSolutionStepValue(VAUX_EQ_TRACTION)[j]; - } - - for(unsigned int j = 0; j < 3; j++) - { - Node0Values[j] = Jac*(MassMat(0,0)*NodalTractions[j] + MassMat(0,1)*NodalTractions[j+3] + MassMat(0,2)*NodalTractions[j+6]); - Node1Values[j] = Jac*(MassMat(1,0)*NodalTractions[j] + MassMat(1,1)*NodalTractions[j+3] + MassMat(1,2)*NodalTractions[j+6]); - Node2Values[j] = Jac*(MassMat(2,0)*NodalTractions[j] + MassMat(2,1)*NodalTractions[j+3] + MassMat(2,2)*NodalTractions[j+6]); - } - - // We are taking advantage of 1 Condition = 2 Gauss Points to iterate the interpolation results and the Gauss Point Vector Again - rGeom[0].FastGetSolutionStepValue(rDestVar) += Node0Values; - rGeom[1].FastGetSolutionStepValue(rDestVar) += Node1Values; - rGeom[2].FastGetSolutionStepValue(rDestVar) += Node2Values; - - IV_iter++; - } - } -} - } // Namespace Kratos. diff --git a/applications/FSIapplication/custom_utilities/AdvancedNMPointsMapper.hpp b/applications/FSIapplication/custom_utilities/AdvancedNMPointsMapper.hpp index 10af4ac2c9d5..9bb3f7b5448a 100644 --- a/applications/FSIapplication/custom_utilities/AdvancedNMPointsMapper.hpp +++ b/applications/FSIapplication/custom_utilities/AdvancedNMPointsMapper.hpp @@ -397,8 +397,7 @@ class AdvancedNMPointsMapper const Variable< array_1d > & rDestVar, const int MaxIter, const double TolIter, - const bool sign_pos, - const bool distributed); + const bool sign_pos); /** * It searches neighbours nodes in a specific radius diff --git a/applications/FSIapplication/custom_utilities/variable_redistribution_utility.cpp b/applications/FSIapplication/custom_utilities/variable_redistribution_utility.cpp new file mode 100644 index 000000000000..f0cae8fa9879 --- /dev/null +++ b/applications/FSIapplication/custom_utilities/variable_redistribution_utility.cpp @@ -0,0 +1,410 @@ +// | / | +// ' / __| _` | __| _ \ __| +// . \ | ( | | ( |\__ ` +// _|\_\_| \__,_|\__|\___/ ____/ +// Multi-Physics +// +// License: BSD License +// Kratos default license: kratos/license.txt +// +// Main authors: Ruben Zorrilla +// Jordi Cotela +// + +#include "fsi_application.h" +#include "variable_redistribution_utility.h" + +namespace Kratos +{ + +void VariableRedistributionUtility::ConvertDistributedValuesToPoint( + ModelPart& rModelPart, + const Variable& rDistributedVariable, + const Variable& rPointVariable) +{ + CallSpecializedConvertDistributedValuesToPoint(rModelPart,rDistributedVariable,rPointVariable); +} + +void VariableRedistributionUtility::DistributePointValues( + ModelPart& rModelPart, + const Variable& rPointVariable, + const Variable& rDistributedVariable, + double Tolerance, + unsigned int MaximumIterations) +{ + CallSpecializedDistributePointValues(rModelPart,rPointVariable,rDistributedVariable, Tolerance, MaximumIterations); +} + +void VariableRedistributionUtility::ConvertDistributedValuesToPoint( + ModelPart& rModelPart, + const Variable< array_1d >& rDistributedVariable, + const Variable< array_1d >& rPointVariable) +{ + CallSpecializedConvertDistributedValuesToPoint(rModelPart,rDistributedVariable,rPointVariable); +} + +void VariableRedistributionUtility::DistributePointValues( + ModelPart& rModelPart, + const Variable< array_1d >& rPointVariable, + const Variable< array_1d >& rDistributedVariable, + double Tolerance, + unsigned int MaximumIterations) +{ + CallSpecializedDistributePointValues(rModelPart,rPointVariable,rDistributedVariable, Tolerance, MaximumIterations); +} + +template< class TValueType > +void VariableRedistributionUtility::CallSpecializedConvertDistributedValuesToPoint( + ModelPart& rModelPart, + const Variable& rDistributedVariable, + const Variable& rPointVariable) +{ + // This function only dispatches the call to the correct specialization + Geometry< Node<3> >& rReferenceGeometry = rModelPart.ConditionsBegin()->GetGeometry(); + const GeometryData::KratosGeometryFamily GeometryFamily = rReferenceGeometry.GetGeometryFamily(); + const unsigned int PointsNumber = rReferenceGeometry.PointsNumber(); + + if (GeometryFamily == GeometryData::Kratos_Linear && PointsNumber == 2) + { + VariableRedistributionUtility::SpecializedConvertDistributedValuesToPoint( + rModelPart, + rDistributedVariable, + rPointVariable); + } + else if (GeometryFamily == GeometryData::Kratos_Triangle && PointsNumber == 3) + { + VariableRedistributionUtility::SpecializedConvertDistributedValuesToPoint( + rModelPart, + rDistributedVariable, + rPointVariable); + } + else + { + KRATOS_ERROR << "Unsupported geometry type with " << PointsNumber << " points." << std::endl; + } +} + +template< class TValueType > +void VariableRedistributionUtility::CallSpecializedDistributePointValues( + ModelPart& rModelPart, + const Variable& rPointVariable, + const Variable& rDistributedVariable, + double Tolerance, + unsigned int MaximumIterations) +{ + // This function only dispatches the call to the correct specialization + Geometry< Node<3> >& rReferenceGeometry = rModelPart.ConditionsBegin()->GetGeometry(); + const GeometryData::KratosGeometryFamily GeometryFamily = rReferenceGeometry.GetGeometryFamily(); + const unsigned int PointsNumber = rReferenceGeometry.PointsNumber(); + + if (GeometryFamily == GeometryData::Kratos_Linear && PointsNumber == 2) + { + VariableRedistributionUtility::SpecializedDistributePointValues( + rModelPart, + rPointVariable, + rDistributedVariable, + Tolerance, + MaximumIterations); + } + else if (GeometryFamily == GeometryData::Kratos_Triangle && PointsNumber == 3) + { + VariableRedistributionUtility::SpecializedDistributePointValues( + rModelPart, + rPointVariable, + rDistributedVariable, + Tolerance, + MaximumIterations); + } + else + { + KRATOS_ERROR << "Unsupported geometry type with " << PointsNumber << " points." << std::endl; + } +} + +/////////////////////////////////////////////////////////////////////////////// + +template< GeometryData::KratosGeometryFamily TFamily, unsigned int TPointNumber, class TValueType > +void VariableRedistributionUtility::SpecializedConvertDistributedValuesToPoint( + ModelPart& rModelPart, + const Variable< TValueType >& rDistributedVariable, + const Variable< TValueType >& rPointVariable) +{ + const int number_of_nodes_in_model_part = rModelPart.NumberOfNodes(); + TValueType Zero = rPointVariable.Zero(); + + // Initialize result to zero + #pragma omp parallel for + for (int i = 0; i < number_of_nodes_in_model_part; i++) + { + ModelPart::NodeIterator node_iter = rModelPart.NodesBegin() + i; + node_iter->FastGetSolutionStepValue(rPointVariable) = Zero; + } + + boost::numeric::ublas::bounded_matrix MassMatrix; + ConsistentMassMatrix(MassMatrix); + + const int number_of_conditions = rModelPart.NumberOfConditions(); + #pragma omp for + for (int i = 0; i < number_of_conditions; i++) + { + auto condition_iterator = rModelPart.ConditionsBegin()+i; + Geometry< Node<3> >& r_geometry = condition_iterator->GetGeometry(); + double size = r_geometry.DomainSize(); + + for (unsigned int j = 0; j < TPointNumber; j++) + { + TValueType value_j = rDistributedVariable.Zero(); + + for (unsigned int k = 0; k < TPointNumber; k++) + { + value_j += size * MassMatrix(j,k) * r_geometry[k].FastGetSolutionStepValue(rDistributedVariable); + } + + ThreadsafeAdd(r_geometry[j].FastGetSolutionStepValue(rPointVariable), value_j); + } + } +} + +/////////////////////////////////////////////////////////////////////////////// + +template< GeometryData::KratosGeometryFamily TFamily, unsigned int TPointNumber, class TValueType > +void VariableRedistributionUtility::SpecializedDistributePointValues( + ModelPart& rModelPart, + const Variable< TValueType >& rPointVariable, + const Variable< TValueType >& rDistributedVariable, + double Tolerance, + unsigned int MaximumIterations) +{ + ComputeNodalSizes(rModelPart); + + boost::numeric::ublas::bounded_matrix< double, TPointNumber, TPointNumber > mass_matrix; + ConsistentMassMatrix(mass_matrix); + + const int number_of_nodes_in_model_part = rModelPart.NumberOfNodes(); + + // Initial guess (NodalValue / NodalSize) + #pragma omp parallel for + for (int i = 0; i < number_of_nodes_in_model_part; i++) + { + ModelPart::NodeIterator node_iter = rModelPart.NodesBegin() + i; + node_iter->FastGetSolutionStepValue(rDistributedVariable) = node_iter->FastGetSolutionStepValue(rPointVariable) / node_iter->GetValue(NODAL_MAUX); + } + + // Iteration: LumpedMass * delta_distributed = point_value - ConsistentMass * distributed_old + unsigned int iteration = 0; + while ( iteration < MaximumIterations ) + { + UpdateDistributionRHS(rModelPart,rPointVariable, rDistributedVariable, mass_matrix); + + double error_l2_norm = SolveDistributionIteration(rModelPart,rDistributedVariable); + + // Check convergence + iteration++; + if (error_l2_norm <= Tolerance*Tolerance) + { + break; + } + } + + if (iteration == MaximumIterations) + { + std::cout << "WARNING: DistributePointValues did not converge in " << iteration << " iterations." << std::endl; + } +} + +/////////////////////////////////////////////////////////////////////////////// + +void VariableRedistributionUtility::ComputeNodalSizes(ModelPart& rModelPart) +{ + const int number_of_nodes = rModelPart.NumberOfNodes(); + #pragma omp for + for (int i = 0; i < number_of_nodes; i++) + { + auto node_iterator = rModelPart.NodesBegin()+i; + node_iterator->SetValue(NODAL_MAUX,0.0); + } + + const int number_of_conditions = rModelPart.NumberOfConditions(); + #pragma omp for + for (int i = 0; i < number_of_conditions; i++) + { + auto condition_iterator = rModelPart.ConditionsBegin()+i; + Geometry< Node<3> >& r_geometry = condition_iterator->GetGeometry(); + const double condition_size = r_geometry.DomainSize(); + const unsigned int nodes_in_condition = r_geometry.PointsNumber(); + const double nodal_factor = 1.0 / double(nodes_in_condition); + for (unsigned int j = 0; j < nodes_in_condition; j++) + { + double& lumped_mass = r_geometry[j].GetValue(NODAL_MAUX); + #pragma omp atomic + lumped_mass += nodal_factor * condition_size; + } + } + + rModelPart.GetCommunicator().AssembleNonHistoricalData(NODAL_MAUX); +} + +template<> +void VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::Kratos_Linear, 2 >( + boost::numeric::ublas::bounded_matrix& rMassMatrix) +{ + // First row + rMassMatrix(0, 0) = 2.0/6.0; + rMassMatrix(0, 1) = 1.0/6.0; + + // Second row + rMassMatrix(1, 0) = 1.0/6.0; + rMassMatrix(1, 1) = 2.0/6.0; +} + + +template<> +void VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::Kratos_Triangle, 3 >( + boost::numeric::ublas::bounded_matrix& rMassMatrix) +{ + // First row + rMassMatrix(0, 0) = 1.0/ 6.0; + rMassMatrix(0, 1) = 1.0/12.0; + rMassMatrix(0, 2) = 1.0/12.0; + + // Second row + rMassMatrix(1, 0) = 1.0/12.0; + rMassMatrix(1, 1) = 1.0/ 6.0; + rMassMatrix(1, 2) = 1.0/12.0; + + // Third row + rMassMatrix(2, 0) = 1.0/12.0; + rMassMatrix(2, 1) = 1.0/12.0; + rMassMatrix(2, 2) = 1.0/ 6.0; +} + +template< unsigned int TNumNodes, class TValueType > +void VariableRedistributionUtility::UpdateDistributionRHS( + ModelPart& rModelPart, + const Variable< TValueType >& rPointVariable, + const Variable< TValueType >& rDistributedVariable, + boost::numeric::ublas::bounded_matrix& rMassMatrix) +{ + const Variable& rhs_variable = GetRHSVariable(rDistributedVariable); + const TValueType rhs_zero = rhs_variable.Zero(); // something of the correct type to initialize our values to zero + + const int number_of_nodes_in_model_part = rModelPart.NumberOfNodes(); + const int number_of_conditions_in_model_part = rModelPart.NumberOfConditions(); + + // Reset the RHS container to zero + #pragma omp parallel for + for (int i_node = 0; i_node < number_of_nodes_in_model_part; i_node++ ) + { + ModelPart::NodesContainerType::iterator node_iter = rModelPart.NodesBegin() + i_node; + node_iter->SetValue(rhs_variable, rhs_zero ); + } + + // Calculate updated RHS + #pragma omp parallel for + for (int i_condition = 0; i_condition < number_of_conditions_in_model_part; i_condition++) + { + auto condition_iterator = rModelPart.ConditionsBegin() + i_condition; + Geometry< Node<3> >& r_geometry = condition_iterator->GetGeometry(); + + const double size = r_geometry.DomainSize(); + + for (unsigned int j = 0; j < TNumNodes; j++) + { + TValueType rhs_j = rhs_zero; + + for (unsigned int k = 0; k < TNumNodes; k++) + { + rhs_j -= size * rMassMatrix(j,k) * r_geometry[k].FastGetSolutionStepValue(rDistributedVariable); + } + + ThreadsafeAdd(r_geometry[j].GetValue(rhs_variable), rhs_j); + } + } + + // Assemble distributed contributions + rModelPart.GetCommunicator().AssembleNonHistoricalData(rhs_variable); + + // Add the nodal part of the RHS (the point-wise values) + #pragma omp parallel for + for (int i_node = 0; i_node < number_of_nodes_in_model_part; i_node++ ) + { + ModelPart::NodesContainerType::iterator node_iter = rModelPart.NodesBegin() + i_node; + node_iter->GetValue(rhs_variable) += node_iter->FastGetSolutionStepValue(rPointVariable); + } +} + +template< class TValueType > +double VariableRedistributionUtility::SolveDistributionIteration( + ModelPart& rModelPart, + const Variable< TValueType >& rDistributedVariable) +{ + + const int number_of_nodes_in_model_part = rModelPart.NumberOfNodes(); + + const Variable& rhs_variable = GetRHSVariable(rDistributedVariable); + TValueType delta = rDistributedVariable.Zero(); + double error_l2_norm = 0.0; + double domain_size = 0.0; + + #pragma omp parallel for reduction(+: error_l2_norm, domain_size) private(delta) + for (int i_node = 0; i_node < number_of_nodes_in_model_part; i_node++) + { + auto node_iter = rModelPart.NodesBegin() + i_node; + + const double size = node_iter->GetValue(NODAL_MAUX); + delta = node_iter->GetValue(rhs_variable) / size; + + TValueType& r_updated_value = node_iter->FastGetSolutionStepValue(rDistributedVariable); + r_updated_value += delta; + + error_l2_norm += AddToNorm(delta, size); + domain_size += size; + } + + return error_l2_norm /= domain_size; +} + +template<> +const Variable& VariableRedistributionUtility::GetRHSVariable(const Variable& rVariable) +{ + return MAPPER_SCALAR_PROJECTION_RHS; +} + +template<> +const Variable< array_1d >& VariableRedistributionUtility::GetRHSVariable< array_1d >(const Variable< array_1d >& rVariable) +{ + return MAPPER_VECTOR_PROJECTION_RHS; +} + + +template<> +double VariableRedistributionUtility::AddToNorm(double NodalValue, double NodalSize) +{ + return NodalSize*NodalValue*NodalValue; +} + + +template<> +double VariableRedistributionUtility::AddToNorm< array_1d >(array_1d NodalValue, double NodalSize) +{ + return NodalSize*( NodalValue[0]*NodalValue[0]+NodalValue[1]*NodalValue[1]+NodalValue[2]*NodalValue[2] ); +} + +template<> +void VariableRedistributionUtility::ThreadsafeAdd(double& rLHS, const double& rRHS) +{ + #pragma omp atomic + rLHS += rRHS; +} + +template<> +void VariableRedistributionUtility::ThreadsafeAdd< array_1d >(array_1d& rLHS, const array_1d& rRHS) +{ + for (unsigned int i = 0; i < 3; i++) + { + #pragma omp atomic + rLHS[i] += rRHS[i]; + } +} + +} \ No newline at end of file diff --git a/applications/FSIapplication/custom_utilities/variable_redistribution_utility.h b/applications/FSIapplication/custom_utilities/variable_redistribution_utility.h new file mode 100644 index 000000000000..2dc63441a569 --- /dev/null +++ b/applications/FSIapplication/custom_utilities/variable_redistribution_utility.h @@ -0,0 +1,323 @@ +// | / | +// ' / __| _` | __| _ \ __| +// . \ | ( | | ( |\__ ` +// _|\_\_| \__,_|\__|\___/ ____/ +// Multi-Physics +// +// License: BSD License +// Kratos default license: kratos/license.txt +// +// Main authors: Ruben Zorrilla +// Jordi Cotela +// + +#if !defined(KRATOS_VARIABLE_REDISTRIBUTION_UTILITY_H_INCLUDED ) +#define KRATOS_VARIABLE_REDISTRIBUTION_UTILITY_H_INCLUDED + + + +// System includes +#include +#include + + +// External includes + + +// Project includes +#include "includes/define.h" +#include "includes/model_part.h" +#include "geometries/geometry_data.h" + + +namespace Kratos +{ + ///@addtogroup FSIApplication + ///@{ + + ///@name Kratos Globals + ///@{ + + ///@} + ///@name Type Definitions + ///@{ + + ///@} + ///@name Enum's + ///@{ + + ///@} + ///@name Functions + ///@{ + + ///@} + ///@name Kratos Classes + ///@{ + + /// Helper utility to transform between point-wise nodal variables and distributed values. + /** The functions are desinged so that both sets of values have the same L2 norm over the + * conditions of the provided ModelPart (up to tolerance). + * A typical use case is to transform a set of point forces to area-distributed loads + * or vice-versa. + */ + class VariableRedistributionUtility + { + public: + ///@name Type Definitions + ///@{ + + /// Pointer definition of VariableRedistributionUtility + KRATOS_CLASS_POINTER_DEFINITION(VariableRedistributionUtility); + + ///@} + ///@name Life Cycle + ///@{ + + + ///@} + ///@name Operators + ///@{ + + + ///@} + ///@name Operations + ///@{ + + /// Tranform a variable distributed over the conditions of rModelPart to a set of concentrated nodal values. + /** The origin and destination values have the same L2 norm over the set of conditions. + * A typical use case is to transform a distributed load into an equivalent set of point loads. + * Version for scalar magnitudes. + * @param rModelPart The model part of the problem + * @param rDistributedVariable The variable containing the distributed (origin) values. + * @param rPointVariable The variable that will contain the point (destination) values. + */ + static void ConvertDistributedValuesToPoint( + ModelPart& rModelPart, + const Variable< double >& rDistributedVariable, + const Variable< double >& rPointVariable); + + + /// Tranform a variable distributed over the conditions of rModelPart to a set of concentrated nodal values. + /** The origin and destination values have the same L2 norm over the set of conditions. + * A typical use case is to transform a distributed load into an equivalent set of point loads. + * Version for vector magnitudes. + * @param rModelPart The model part of the problem + * @param rDistributedVariable The variable containing the distributed (origin) values. + * @param rPointVariable The variable that will contain the point (destination) values. + */ + static void ConvertDistributedValuesToPoint( + ModelPart& rModelPart, + const Variable< array_1d >& rDistributedVariable, + const Variable< array_1d >& rPointVariable); + + /// Tranform a set of concentrated nodal values to a variable distributed over the conditions of rModelPart. + /** The origin and destination values have the same L2 norm over the set of conditions. + * A typical use case is to transform a set of point loads into an equivalent distributed load. + * Version for scalar magnitudes. + * @param rModelPart The model part of the problem + * @param rPointVariable The variable that will contain the point (origin) values. + * @param rDistributedVariable The variable containing the distributed (destination) values. + * @param Tolerance Maximum allowed difference (in L2 norm) between origin and destination values. + * @param MaximumIterations Maximum number of iterations for the procedure. + */ + static void DistributePointValues( + ModelPart& rModelPart, + const Variable< double >& rPointVariable, + const Variable< double >& rDistributedVariable, + double Tolerance, + unsigned int MaximumIterations); + + /// Tranform a set of concentrated nodal values to a variable distributed over the conditions of rModelPart. + /** The origin and destination values have the same L2 norm over the set of conditions. + * A typical use case is to transform a set of point loads into an equivalent distributed load. + * Version for vector magnitudes. + * @param rModelPart The model part of the problem + * @param rPointVariable The variable that will contain the point (origin) values. + * @param rDistributedVariable The variable containing the distributed (destination) values. + * @param Tolerance Maximum allowed difference (in L2 norm) between origin and destination values. + * @param MaximumIterations Maximum number of iterations for the procedure. + */ + static void DistributePointValues( + ModelPart& rModelPart, + const Variable< array_1d >& rPointVariable, + const Variable< array_1d >& rDistributedVariable, + double Tolerance, + unsigned int MaximumIterations); + + ///@} + ///@name Access + ///@{ + + + ///@} + ///@name Inquiry + ///@{ + + + ///@} + ///@name Input and output + ///@{ + + + ///@} + ///@name Friends + ///@{ + + + ///@} + + protected: + ///@name Protected static Member Variables + ///@{ + + + ///@} + ///@name Protected member Variables + ///@{ + + + ///@} + ///@name Protected Operators + ///@{ + + + ///@} + ///@name Protected Operations + ///@{ + + + ///@} + ///@name Protected Access + ///@{ + + + ///@} + ///@name Protected Inquiry + ///@{ + + + ///@} + ///@name Protected LifeCycle + ///@{ + + + ///@} + + private: + ///@name Static Member Variables + ///@{ + + ///@} + ///@name Member Variables + ///@{ + + + ///@} + ///@name Private Operators + ///@{ + + + ///@} + ///@name Private Operations + ///@{ + + template< class TValueType > + static void CallSpecializedConvertDistributedValuesToPoint( + ModelPart& rModelPart, + const Variable< TValueType >& rDistributedVariable, + const Variable< TValueType >& rPointVariable); + + template< class TValueType > + static void CallSpecializedDistributePointValues( + ModelPart& rModelPart, + const Variable< TValueType >& rPointVariable, + const Variable< TValueType >& rDistributedVariable, + double Tolerance, + unsigned int MaximumIterations); + + template< GeometryData::KratosGeometryFamily TFamily, unsigned int TPointNumber, class TValueType > + static void SpecializedConvertDistributedValuesToPoint( + ModelPart& rModelPart, + const Variable< TValueType >& rDistributedVariable, + const Variable< TValueType >& rPointVariable); + + template< GeometryData::KratosGeometryFamily TFamily, unsigned int TPointNumber, class TValueType > + static void SpecializedDistributePointValues( + ModelPart& rModelPart, + const Variable< TValueType >& rPointVariable, + const Variable< TValueType >& rDistributedVariable, + double Tolerance, + unsigned int MaximumIterations); + + static void ComputeNodalSizes(ModelPart& rModelPart); + + template< GeometryData::KratosGeometryFamily TFamily, unsigned int TNumNodes > + static void ConsistentMassMatrix(boost::numeric::ublas::bounded_matrix& rMassMatrix); + + template< unsigned int TNumNodes, class TValueType > + static void UpdateDistributionRHS( + ModelPart& rModelPart, + const Variable< TValueType >& rPointVariable, + const Variable< TValueType >& rDistributedVariable, + boost::numeric::ublas::bounded_matrix& rMassMatrix); + + template< class TValueType > + static double SolveDistributionIteration( + ModelPart& rModelPart, + const Variable< TValueType >& rDistributedVariable); + + template< class TValueType > + static const Variable< TValueType >& GetRHSVariable(const Variable& rVariable); + + template< class TValueType > + static double AddToNorm(TValueType NodalValue, double NodalSize); + + template< class TValueType > + static void ThreadsafeAdd(TValueType& rLHS, const TValueType& rRHS); + + ///@} + ///@name Private Access + ///@{ + + + ///@} + ///@name Private Inquiry + ///@{ + + + ///@} + ///@name Un accessible methods + ///@{ + + /// Default constructor. + VariableRedistributionUtility(); + + /// Assignment operator. + VariableRedistributionUtility& operator=(VariableRedistributionUtility const& rOther); + + /// Copy constructor. + VariableRedistributionUtility(VariableRedistributionUtility const& rOther); + + + ///@} + + }; // Class VariableRedistributionUtility + + ///@} + + ///@name Type Definitions + ///@{ + + + ///@} + ///@name Input and output + ///@{ + + + ///@} + + ///@} addtogroup block + +} // namespace Kratos. + +#endif // KRATOS_VARIABLE_REDISTRIBUTION_UTILITY_H_INCLUDED defined diff --git a/applications/FSIapplication/python_scripts/NonConformant_OneSideMap.py b/applications/FSIapplication/python_scripts/NonConformant_OneSideMap.py index 14a59eda568e..60d3ce61b040 100644 --- a/applications/FSIapplication/python_scripts/NonConformant_OneSideMap.py +++ b/applications/FSIapplication/python_scripts/NonConformant_OneSideMap.py @@ -86,13 +86,23 @@ def RecomputeTransferPairs(self, search_radius_factor): # Standard mappers def StructureToFluid_VectorMap(self, VectorVar_Origin, VectorVar_Destination, sign_pos, distributed): - (self.StructureToFluidMapper).VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos, distributed) + if distributed: + VariableRedistributionUtility.DistributePointValues(self.str_interface,VectorVar_Origin,VAUX_EQ_TRACTION,self.tol,self.it_max) + self.StructureToFluidMapper.VectorMap(VAUX_EQ_TRACTION, VAUX_EQ_TRACTION, self.it_max, self.tol, sign_pos) + VariableRedistributionUtility.ConvertDistributedValuesToPoint(self.fl_interface,VAUX_EQ_TRACTION,VectorVar_Destination) + else: + self.StructureToFluidMapper.VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos) def StructureToFluid_ScalarMap(self, ScalarVar_Origin, ScalarVar_Destination, sign_pos): (self.StructureToFluidMapper).ScalarMap(ScalarVar_Origin, ScalarVar_Destination, self.it_max, self.tol, sign_pos) def FluidToStructure_VectorMap(self, VectorVar_Origin, VectorVar_Destination, sign_pos, distributed): - (self.FluidToStructureMapper).VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos, distributed) + if distributed: + VariableRedistributionUtility.DistributePointValues(self.fl_interface,VectorVar_Origin,VAUX_EQ_TRACTION,self.tol,self.it_max) + self.FluidToStructureMapper.VectorMap(VAUX_EQ_TRACTION, VAUX_EQ_TRACTION, self.it_max, self.tol, sign_pos) + VariableRedistributionUtility.ConvertDistributedValuesToPoint(self.str_interface,VAUX_EQ_TRACTION,VectorVar_Destination) + else: + self.FluidToStructureMapper.VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos) def FluidToStructure_ScalarMap(self, ScalarVar_Origin, ScalarVar_Destination, sign_pos): (self.FluidToStructureMapper).ScalarMap(ScalarVar_Origin, ScalarVar_Destination, self.it_max, self.tol, sign_pos) @@ -128,6 +138,10 @@ def __init__(self, fluid_model_part_positive, fluid_model_part_negative, structu self.it_max = it_max self.tol = tol + self.fluid_model_part_positive = fluid_model_part_positive + self.fluid_model_part_negative = fluid_model_part_negative + self.structure_model_part = structure_model_part + self.PositiveFluidToStructureMapper = AdvancedNMPointsMapper(fluid_model_part_positive, structure_model_part) self.NegativeFluidToStructureMapper = AdvancedNMPointsMapper(fluid_model_part_negative, structure_model_part) self.StructureToPositiveFluidMapper = AdvancedNMPointsMapper(structure_model_part, fluid_model_part_positive) @@ -149,26 +163,46 @@ def RecomputeTransferPairs(self, search_radius_factor=2.0): # Standard mappers for positive fluid face def StructureToPositiveFluid_VectorMap(self, VectorVar_Origin, VectorVar_Destination, sign_pos, distributed): - (self.StructureToPositiveFluidMapper).VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos, distributed) + if distributed: + VariableRedistributionUtility.DistributePointValues(self.structure_model_part,VectorVar_Origin,VAUX_EQ_TRACTION,self.tol,self.it_max) + self.StructureToPositiveFluidMapper.VectorMap(VAUX_EQ_TRACTION, VAUX_EQ_TRACTION, self.it_max, self.tol, sign_pos) + VariableRedistributionUtility.ConvertDistributedValuesToPoint(self.positive_fluid,VAUX_EQ_TRACTION,VectorVar_Destination) + else: + self.StructureToPositiveFluidMapper.VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos) def StructureToPositiveFluid_ScalarMap(self, ScalarVar_Origin, ScalarVar_Destination, sign_pos): (self.StructureToPositiveFluidMapper).ScalarMap(ScalarVar_Origin, ScalarVar_Destination, self.it_max, self.tol, sign_pos) def PositiveFluidToStructure_VectorMap(self, VectorVar_Origin, VectorVar_Destination, sign_pos, distributed): - (self.PositiveFluidToStructureMapper).VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos, distributed) + if distributed: + VariableRedistributionUtility.DistributePointValues(self.fluid_model_part_positive,VectorVar_Origin,VAUX_EQ_TRACTION,self.tol,self.it_max) + self.PositiveFluidToStructureMapper.VectorMap(VAUX_EQ_TRACTION, VAUX_EQ_TRACTION, self.it_max, self.tol, sign_pos) + VariableRedistributionUtility.ConvertDistributedValuesToPoint(self.structure_model_part,VAUX_EQ_TRACTION,VectorVar_Destination) + else: + self.PositiveFluidToStructureMapper.VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos) def PositiveFluidToStructure_ScalarMap(self, ScalarVar_Origin, ScalarVar_Destination, sign_pos): (self.PositiveFluidToStructureMapper).ScalarMap(ScalarVar_Origin, ScalarVar_Destination, self.it_max, self.tol, sign_pos) # Standard mappers for negative fluid face def StructureToNegativeFluid_VectorMap(self, VectorVar_Origin, VectorVar_Destination, sign_pos, distributed): - (self.StructureToNegativeFluidMapper).VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos, distributed) + if distributed: + VariableRedistributionUtility.DistributePointValues(self.structure_model_part,VectorVar_Origin,VAUX_EQ_TRACTION,self.tol,self.it_max) + self.StructureToNegativeFluidMapper.VectorMap(VAUX_EQ_TRACTION, VAUX_EQ_TRACTION, self.it_max, self.tol, sign_pos) + VariableRedistributionUtility.ConvertDistributedValuesToPoint(self.negative_fluid,VAUX_EQ_TRACTION,VectorVar_Destination) + else: + self.StructureToNegativeFluidMapper.VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos) def StructureToNegativeFluid_ScalarMap(self, ScalarVar_Origin, ScalarVar_Destination, sign_pos): (self.StructureToNegativeFluidMapper).ScalarMap(ScalarVar_Origin, ScalarVar_Destination, self.it_max, self.tol, sign_pos) def NegativeFluidToStructure_VectorMap(self, VectorVar_Origin, VectorVar_Destination, sign_pos, distributed): - (self.NegativeFluidToStructureMapper).VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos, distributed) + if distributed: + VariableRedistributionUtility.DistributePointValues(self.fluid_model_part_negative,VectorVar_Origin,VAUX_EQ_TRACTION,self.tol,self.it_max) + self.NegativeFluidToStructureMapper.VectorMap(VAUX_EQ_TRACTION, VAUX_EQ_TRACTION, self.it_max, self.tol, sign_pos) + VariableRedistributionUtility.ConvertDistributedValuesToPoint(self.structure_model_part,VAUX_EQ_TRACTION,VectorVar_Destination) + else: + self.NegativeFluidToStructureMapper.VectorMap(VectorVar_Origin, VectorVar_Destination, self.it_max, self.tol, sign_pos) def NegativeFluidToStructure_ScalarMap(self, ScalarVar_Origin, ScalarVar_Destination, sign_pos): (self.NegativeFluidToStructureMapper).ScalarMap(ScalarVar_Origin, ScalarVar_Destination, self.it_max, self.tol, sign_pos) diff --git a/applications/FSIapplication/python_scripts/partitioned_fsi_base_solver.py b/applications/FSIapplication/python_scripts/partitioned_fsi_base_solver.py index cbdf74d6cc81..401d823448ba 100644 --- a/applications/FSIapplication/python_scripts/partitioned_fsi_base_solver.py +++ b/applications/FSIapplication/python_scripts/partitioned_fsi_base_solver.py @@ -3,6 +3,7 @@ # Import utilities import NonConformant_OneSideMap # Import non-conformant mapper import python_solvers_wrapper_fluid # Import the fluid Python solvers wrapper +import python_solvers_wrapper_structural # Import the structure Python solvers wrapper # Import kratos core and applications import KratosMultiphysics @@ -184,9 +185,8 @@ def __init__(self, structure_main_model_part, fluid_main_model_part, project_par coupling_utility_parameters = self.settings["coupling_solver_settings"]["coupling_strategy"] # Construct the structure solver - structure_solver_module = __import__(self.settings["structure_solver_settings"]["solver_type"].GetString()) - self.structure_solver = structure_solver_module.CreateSolver(self.structure_main_model_part, - self.settings["structure_solver_settings"]) + self.structure_solver = python_solvers_wrapper_structural.CreateSolver(self.structure_main_model_part, + project_parameters["structure_solver_settings"]) print("* Structure solver constructed.") # Construct the fluid solver diff --git a/applications/FSIapplication/python_scripts/partitioned_fsi_dirichlet_neumann_solver.py b/applications/FSIapplication/python_scripts/partitioned_fsi_dirichlet_neumann_solver.py index 3c15e2c7d499..7784d760a732 100644 --- a/applications/FSIapplication/python_scripts/partitioned_fsi_dirichlet_neumann_solver.py +++ b/applications/FSIapplication/python_scripts/partitioned_fsi_dirichlet_neumann_solver.py @@ -196,7 +196,7 @@ def _SolveMeshAndFluid(self): self._ComputeCorrectedInterfaceDisplacementDerivatives() # Solve fluid problem - self.fluid_solver.SolverSolveSolutionStep() + self.fluid_solver.SolveSolutionStep() def _SolveStructureSingleFaced(self): diff --git a/applications/FSIapplication/tests/KratosExecuteFSIProblemEmulatorTest.py b/applications/FSIapplication/tests/KratosExecuteFSIProblemEmulatorTest.py index 49bccea0fce1..19e313288ae5 100644 --- a/applications/FSIapplication/tests/KratosExecuteFSIProblemEmulatorTest.py +++ b/applications/FSIapplication/tests/KratosExecuteFSIProblemEmulatorTest.py @@ -110,8 +110,7 @@ def Solve(self): self.coupling_utility.InitializeSolutionStep() for nl_it in range(1,max_nl_it+1): - self.structure_solver.main_model_part.ProcessInfo[KratosFSI.CONVERGENCE_ACCELERATOR_ITERATION] = nl_it ###### USELESS?¿?¿ - + self.coupling_utility.InitializeNonLinearIteration() # Residual computation diff --git a/applications/FSIapplication/tests/RedistributionTest/redistribution_test.mdpa b/applications/FSIapplication/tests/RedistributionTest/redistribution_test.mdpa new file mode 100644 index 000000000000..a80f11c47793 --- /dev/null +++ b/applications/FSIapplication/tests/RedistributionTest/redistribution_test.mdpa @@ -0,0 +1,1887 @@ +Begin ModelPartData +// VARIABLE_NAME value +End ModelPartData + +Begin Properties 0 +End Properties + + +Begin Nodes +1 0.00000e+00 0.00000e+00 0.00000e+00 +2 0.00000e+00 3.33333e-01 0.00000e+00 +3 3.33333e-01 0.00000e+00 0.00000e+00 +4 0.00000e+00 0.00000e+00 3.33333e-01 +5 2.03449e-01 3.03105e-01 2.01957e-01 +6 2.12269e-01 1.90520e-01 4.04834e-01 +7 3.77764e-01 1.92048e-01 2.60270e-01 +8 4.44195e-01 2.88155e-01 0.00000e+00 +9 0.00000e+00 4.86762e-01 3.12413e-01 +10 2.42467e-01 3.58827e-01 3.92872e-01 +11 5.13238e-01 0.00000e+00 3.12413e-01 +12 1.01897e-01 7.28974e-02 6.13436e-01 +13 4.18578e-01 4.24533e-01 2.39627e-01 +14 0.00000e+00 2.92318e-01 5.79557e-01 +15 6.29610e-01 1.34512e-01 1.69163e-01 +16 0.00000e+00 6.66667e-01 0.00000e+00 +17 6.66667e-01 0.00000e+00 0.00000e+00 +18 0.00000e+00 0.00000e+00 6.66667e-01 +19 2.39696e-01 5.67685e-01 2.55648e-01 +20 3.05491e-01 6.02483e-01 0.00000e+00 +21 3.71745e-01 0.00000e+00 6.28255e-01 +22 4.77137e-01 1.23774e-01 5.41275e-01 +23 2.79070e-01 2.99844e-01 6.10194e-01 +24 7.44027e-01 2.93069e-01 0.00000e+00 +25 6.91396e-01 3.84268e-01 1.41265e-01 +26 6.77408e-01 2.41008e-01 3.96527e-01 +27 4.76620e-01 6.46343e-01 2.22390e-01 +28 6.24379e-01 5.59093e-01 0.00000e+00 +29 1.14360e-01 7.75319e-01 3.00744e-01 +30 3.96204e-01 5.93198e-01 4.54105e-01 +31 1.02111e-01 2.44266e-01 8.22131e-01 +32 1.54717e-01 6.86836e-01 5.20576e-01 +33 8.59440e-01 1.20300e-01 1.20745e-01 +34 5.36006e-01 3.88663e-01 5.77321e-01 +35 2.83077e-01 8.19512e-01 1.56713e-01 +36 1.15919e-01 4.96941e-01 7.18527e-01 +37 0.00000e+00 6.28255e-01 6.28255e-01 +38 6.39664e-01 5.04701e-01 3.66510e-01 +39 7.07682e-01 0.00000e+00 5.79557e-01 +40 4.99990e-01 7.77453e-01 0.00000e+00 +41 3.00896e-01 7.78481e-01 3.98476e-01 +42 4.63067e-01 2.84040e-01 7.90194e-01 +43 0.00000e+00 1.00000e+00 0.00000e+00 +44 1.00000e+00 0.00000e+00 0.00000e+00 +45 0.00000e+00 0.00000e+00 1.00000e+00 +46 4.89940e-01 7.92862e-01 3.97481e-01 +47 7.04249e-01 1.67007e-01 7.14409e-01 +48 3.00536e-01 1.00000e+00 0.00000e+00 +49 1.00000e+00 3.00536e-01 0.00000e+00 +50 1.47145e-01 9.31721e-01 4.65018e-01 +51 4.13871e-01 5.77959e-01 7.76167e-01 +52 0.00000e+00 3.33333e-01 1.00000e+00 +53 3.33333e-01 0.00000e+00 1.00000e+00 +54 0.00000e+00 1.00000e+00 3.33333e-01 +55 1.00000e+00 0.00000e+00 3.33333e-01 +56 8.06187e-01 4.25831e-01 5.49137e-01 +57 8.22370e-01 6.49477e-01 2.00157e-01 +58 6.32814e-01 6.45063e-01 5.73378e-01 +59 6.17878e-01 8.56594e-01 2.01012e-01 +60 4.32724e-01 7.64363e-01 6.38100e-01 +61 7.52572e-01 7.92327e-01 0.00000e+00 +62 1.00000e+00 3.65423e-01 2.51826e-01 +63 3.65423e-01 1.00000e+00 2.51826e-01 +64 2.88152e-01 4.44196e-01 1.00000e+00 +65 6.78703e-01 5.09424e-01 7.74758e-01 +66 6.01072e-01 1.00000e+00 0.00000e+00 +67 1.00000e+00 6.01072e-01 0.00000e+00 +68 3.15479e-01 1.00000e+00 5.40779e-01 +69 1.00000e+00 3.15479e-01 5.40779e-01 +70 0.00000e+00 6.66667e-01 1.00000e+00 +71 6.66667e-01 0.00000e+00 1.00000e+00 +72 0.00000e+00 1.00000e+00 6.66667e-01 +73 1.00000e+00 0.00000e+00 6.66667e-01 +74 6.02482e-01 3.05491e-01 1.00000e+00 +75 7.92232e-01 8.09750e-01 4.31090e-01 +76 1.53848e-01 8.79820e-01 8.20553e-01 +77 1.00000e+00 5.80894e-01 3.77456e-01 +78 5.80894e-01 1.00000e+00 3.77456e-01 +79 8.36752e-01 3.26244e-01 8.31758e-01 +80 8.09104e-01 1.85088e-01 9.25110e-01 +81 1.21962e+00 1.46857e-01 2.35472e-01 +82 6.04827e-01 7.86267e-01 7.85523e-01 +83 2.93068e-01 7.44032e-01 1.00000e+00 +84 1.20740e+00 4.63297e-01 0.00000e+00 +85 8.26148e-01 1.00000e+00 0.00000e+00 +86 1.00000e+00 8.26148e-01 0.00000e+00 +87 1.30054e+00 0.00000e+00 0.00000e+00 +88 3.93585e-01 8.80093e-01 8.78148e-01 +89 5.59092e-01 6.24380e-01 1.00000e+00 +90 8.09259e-01 1.00000e+00 2.42156e-01 +91 1.00000e+00 8.09259e-01 2.42156e-01 +92 8.56593e-01 6.17878e-01 7.98987e-01 +93 1.16437e+00 6.17802e-01 1.79863e-01 +94 1.25264e+00 4.13155e-01 2.64037e-01 +95 1.15615e+00 5.08700e-01 4.74034e-01 +96 5.75827e-01 1.00000e+00 7.04407e-01 +97 1.00000e+00 5.75827e-01 7.04407e-01 +98 8.42003e-01 8.30932e-01 6.57592e-01 +99 7.77452e-01 4.99989e-01 1.00000e+00 +100 1.21022e+00 6.47222e-01 0.00000e+00 +101 1.36542e+00 0.00000e+00 2.51826e-01 +102 1.00000e+00 8.18306e-01 5.25572e-01 +103 8.18306e-01 1.00000e+00 5.25572e-01 +104 1.13039e+00 8.08613e-01 1.40231e-01 +105 1.00000e+00 1.00000e+00 0.00000e+00 +106 0.00000e+00 1.00000e+00 1.00000e+00 +107 1.00000e+00 0.00000e+00 1.00000e+00 +108 1.38894e+00 2.80211e-01 0.00000e+00 +109 1.31548e+00 0.00000e+00 5.40779e-01 +110 1.00000e+00 1.00000e+00 1.64614e-01 +111 1.32221e+00 2.17677e-01 4.98582e-01 +112 1.10228e+00 8.71035e-01 3.25621e-01 +113 3.00536e-01 1.00000e+00 1.00000e+00 +114 1.00000e+00 3.00536e-01 1.00000e+00 +115 1.19866e+00 8.27472e-01 0.00000e+00 +116 1.00000e+00 1.00000e+00 3.77730e-01 +117 1.27129e+00 7.29891e-01 1.14565e-01 +118 1.33629e+00 6.02736e-01 2.09388e-01 +119 7.92327e-01 7.52572e-01 1.00000e+00 +120 1.43001e+00 2.97522e-01 2.47702e-01 +121 1.26204e+00 1.81805e-01 7.91772e-01 +122 1.31932e+00 6.22345e-01 3.56082e-01 +123 1.27323e+00 7.57612e-01 2.46556e-01 +124 8.09544e-01 1.00000e+00 7.75074e-01 +125 1.00000e+00 8.09544e-01 7.75074e-01 +126 1.39984e+00 5.50398e-01 0.00000e+00 +127 1.22974e+00 4.00507e-01 7.78504e-01 +128 1.24753e+00 5.84352e-01 6.23161e-01 +129 1.15643e+00 9.87688e-01 0.00000e+00 +130 6.01072e-01 1.00000e+00 1.00000e+00 +131 1.00000e+00 6.01072e-01 1.00000e+00 +132 1.27699e+00 8.62326e-01 1.15913e-01 +133 1.39396e+00 4.74610e-01 4.77968e-01 +134 1.32329e+00 8.08450e-01 0.00000e+00 +135 1.19007e+00 9.81770e-01 1.70873e-01 +136 1.16437e+00 6.17802e-01 8.20137e-01 +137 1.00000e+00 1.00000e+00 6.47348e-01 +138 1.39587e+00 7.61062e-01 1.28399e-01 +139 1.60107e+00 0.00000e+00 0.00000e+00 +140 1.15753e+00 9.87514e-01 5.11742e-01 +141 1.56699e+00 3.41169e-01 1.06764e-01 +142 1.32276e+00 8.09530e-01 4.41155e-01 +143 1.44458e+00 7.25494e-01 0.00000e+00 +144 1.30902e+00 9.51057e-01 0.00000e+00 +145 1.58089e+00 0.00000e+00 3.77456e-01 +146 1.56651e+00 4.37010e-01 0.00000e+00 +147 1.13039e+00 8.08613e-01 8.59769e-01 +148 1.27918e+00 9.60240e-01 3.37029e-01 +149 1.20740e+00 4.63297e-01 1.00000e+00 +150 1.61781e+00 1.64379e-01 1.79853e-01 +151 8.26148e-01 1.00000e+00 1.00000e+00 +152 1.00000e+00 8.26148e-01 1.00000e+00 +153 1.49133e+00 5.84812e-01 3.53661e-01 +154 1.30054e+00 0.00000e+00 1.00000e+00 +155 1.00000e+00 1.00000e+00 8.41243e-01 +156 1.52538e+00 3.46863e-01 5.13694e-01 +157 1.46258e+00 3.06881e-01 7.20988e-01 +158 1.64724e+00 2.10235e-01 0.00000e+00 +159 1.43943e+00 6.87524e-01 4.72663e-01 +160 1.37109e+00 9.28595e-01 1.61225e-01 +161 1.46851e+00 7.29729e-01 3.14812e-01 +162 1.60723e+00 4.23526e-01 1.95772e-01 +163 1.55258e+00 6.46993e-01 0.00000e+00 +164 1.38250e+00 3.89652e-01 8.77305e-01 +165 1.51887e+00 7.20773e-01 1.26889e-01 +166 1.63053e+00 1.98180e-01 3.82743e-01 +167 1.29797e+00 7.78804e-01 7.48111e-01 +168 1.34837e+00 5.91944e-01 8.44024e-01 +169 1.21022e+00 6.47222e-01 1.00000e+00 +170 1.45399e+00 8.91007e-01 0.00000e+00 +171 1.48897e+00 5.20853e-01 6.56420e-01 +172 1.27129e+00 7.29891e-01 8.85435e-01 +173 1.61623e+00 4.09512e-01 4.12957e-01 +174 1.60663e+00 5.90163e-01 1.52929e-01 +175 1.57583e+00 0.00000e+00 7.04407e-01 +176 1.47415e+00 1.28995e-01 8.96286e-01 +177 1.00000e+00 1.00000e+00 1.00000e+00 +178 1.27283e+00 9.62063e-01 6.77536e-01 +179 1.45399e+00 8.91006e-01 3.13587e-01 +180 1.38894e+00 2.80211e-01 1.00000e+00 +181 1.57935e+00 6.91764e-01 2.40528e-01 +182 1.57885e+00 6.67688e-01 3.51361e-01 +183 1.52250e+00 8.52640e-01 1.45862e-01 +184 1.45014e+00 7.06421e-01 6.95503e-01 +185 1.73543e+00 2.59633e-01 1.13846e-01 +186 1.19521e+00 9.80761e-01 8.38190e-01 +187 1.67215e+00 5.64697e-01 0.00000e+00 +188 1.19866e+00 8.27472e-01 1.00000e+00 +189 1.42387e+00 9.05721e-01 5.27387e-01 +190 1.72550e+00 4.44590e-01 0.00000e+00 +191 1.58779e+00 8.09017e-01 0.00000e+00 +192 1.30998e+00 8.34225e-01 8.80622e-01 +193 1.65827e+00 6.04802e-01 2.91007e-01 +194 1.63636e+00 5.28919e-01 5.37669e-01 +195 1.39984e+00 5.50398e-01 1.00000e+00 +196 1.68209e+00 1.84653e-01 6.39864e-01 +197 1.76107e+00 3.95866e-01 1.28398e-01 +198 1.60052e+00 7.99612e-01 2.82490e-01 +199 1.39587e+00 7.61062e-01 8.71601e-01 +200 1.80862e+00 1.30394e-01 1.40229e-01 +201 1.73556e+00 5.32357e-01 1.16157e-01 +202 1.15643e+00 9.87688e-01 1.00000e+00 +203 1.64945e+00 7.60406e-01 1.45861e-01 +204 1.64387e+00 4.09969e-01 6.72972e-01 +205 1.80926e+00 0.00000e+00 2.42156e-01 +206 1.82615e+00 0.00000e+00 0.00000e+00 +207 1.80846e+00 3.23298e-01 0.00000e+00 +208 1.82748e+00 1.98660e-01 0.00000e+00 +209 1.43816e+00 8.98898e-01 7.17892e-01 +210 1.32329e+00 8.08450e-01 1.00000e+00 +211 1.70711e+00 7.07107e-01 0.00000e+00 +212 1.74060e+00 3.48788e-01 5.13821e-01 +213 1.65956e+00 3.28051e-01 7.45139e-01 +214 1.59693e+00 4.37232e-01 8.29374e-01 +215 1.65268e+00 1.41351e-01 8.23359e-01 +216 1.69811e+00 7.15988e-01 2.76270e-01 +217 1.38268e+00 9.23880e-01 8.54138e-01 +218 1.65392e+00 7.56561e-01 4.49075e-01 +219 1.83058e+00 3.20445e-01 2.78905e-01 +220 1.66237e+00 5.43048e-01 6.91466e-01 +221 1.76041e+00 6.49448e-01 1.45861e-01 +222 1.86233e+00 2.76992e-01 1.15911e-01 +223 1.60107e+00 0.00000e+00 1.00000e+00 +224 1.81831e+00 0.00000e+00 5.25572e-01 +225 1.57343e+00 8.19256e-01 6.76261e-01 +226 1.44458e+00 7.25494e-01 1.00000e+00 +227 1.30902e+00 9.51057e-01 1.00000e+00 +228 1.80902e+00 5.87785e-01 0.00000e+00 +229 1.52832e+00 7.27168e-01 8.76090e-01 +230 1.56651e+00 4.37010e-01 1.00000e+00 +231 1.60663e+00 5.90163e-01 8.47071e-01 +232 1.83577e+00 1.99476e-01 5.45744e-01 +233 1.80902e+00 5.87786e-01 3.13586e-01 +234 1.85264e+00 5.22499e-01 1.45862e-01 +235 1.76966e+00 2.34185e-01 7.42901e-01 +236 1.64724e+00 2.10235e-01 1.00000e+00 +237 1.52250e+00 8.52640e-01 8.54138e-01 +238 1.71404e+00 2.89789e-01 8.68649e-01 +239 1.77603e+00 4.83418e-01 6.23836e-01 +240 1.89101e+00 4.53991e-01 0.00000e+00 +241 1.79632e+00 3.70186e-01 6.80441e-01 +242 1.55258e+00 6.46993e-01 1.00000e+00 +243 1.88240e+00 4.70495e-01 2.94882e-01 +244 1.92388e+00 3.82684e-01 1.45862e-01 +245 1.80954e+00 0.00000e+00 7.75074e-01 +246 1.70711e+00 7.07107e-01 6.86414e-01 +247 1.95106e+00 3.09017e-01 0.00000e+00 +248 1.45399e+00 8.91007e-01 1.00000e+00 +249 1.75538e+00 4.91224e-01 7.79966e-01 +250 1.86172e+00 8.65824e-02 6.86803e-01 +251 1.84784e+00 5.30259e-01 5.20338e-01 +252 1.98769e+00 1.56434e-01 0.00000e+00 +253 1.98031e+00 1.97470e-01 1.75143e-01 +254 2.00000e+00 0.00000e+00 0.00000e+00 +255 1.71622e+00 5.41028e-01 8.78327e-01 +256 1.76107e+00 3.95866e-01 8.71602e-01 +257 1.94671e+00 3.22076e-01 3.62651e-01 +258 2.00000e+00 0.00000e+00 1.64614e-01 +259 1.64945e+00 7.60406e-01 8.54139e-01 +260 1.81533e+00 1.53862e-01 8.58922e-01 +261 1.67215e+00 5.64697e-01 1.00000e+00 +262 2.00000e+00 0.00000e+00 3.77730e-01 +263 1.81637e+00 5.77533e-01 7.23730e-01 +264 1.72550e+00 4.44590e-01 1.00000e+00 +265 1.58779e+00 8.09017e-01 1.00000e+00 +266 1.85335e+00 2.86849e-01 8.54116e-01 +267 1.76041e+00 6.49448e-01 8.54139e-01 +268 1.88370e+00 4.68063e-01 7.17510e-01 +269 1.96120e+00 2.75846e-01 6.14859e-01 +270 1.82615e+00 0.00000e+00 1.00000e+00 +271 1.80846e+00 3.23298e-01 1.00000e+00 +272 1.82748e+00 1.98660e-01 1.00000e+00 +273 1.70711e+00 7.07107e-01 1.00000e+00 +274 2.00000e+00 0.00000e+00 6.47348e-01 +275 1.85264e+00 5.22499e-01 8.54138e-01 +276 1.92786e+00 3.72919e-01 8.35462e-01 +277 1.80902e+00 5.87785e-01 1.00000e+00 +278 1.98188e+00 1.89515e-01 8.26265e-01 +279 2.00000e+00 0.00000e+00 8.41243e-01 +280 1.89101e+00 4.53991e-01 1.00000e+00 +281 1.95106e+00 3.09017e-01 1.00000e+00 +282 1.98769e+00 1.56434e-01 1.00000e+00 +283 2.00000e+00 0.00000e+00 1.00000e+00 +End Nodes + +Begin Elements Element3D4N +1 0 177 155 152 151 +2 0 110 105 86 85 +3 0 155 137 125 124 +4 0 116 110 91 90 +5 0 155 125 152 124 +6 0 155 151 124 152 +7 0 110 91 90 85 +8 0 91 110 86 85 +9 0 125 137 102 98 +10 0 137 102 98 103 +11 0 98 137 103 124 +12 0 103 98 124 96 +13 0 98 137 124 125 +14 0 102 98 103 75 +15 0 98 103 75 96 +16 0 124 98 125 119 +17 0 137 102 103 116 +18 0 98 124 96 119 +19 0 66 61 85 90 +20 0 131 119 152 125 +21 0 102 125 98 97 +22 0 86 85 61 91 +23 0 151 152 119 124 +24 0 102 103 116 75 +25 0 102 98 75 97 +26 0 91 116 90 75 +27 0 116 91 102 75 +28 0 116 103 90 75 +29 0 66 40 61 59 +30 0 66 40 59 63 +31 0 40 61 59 28 +32 0 131 99 119 92 +33 0 131 99 92 114 +34 0 99 119 92 89 +35 0 61 66 59 90 +36 0 119 131 92 125 +37 0 119 152 125 124 +38 0 130 124 151 119 +39 0 61 85 90 91 +40 0 86 67 91 61 +41 0 131 92 125 97 +42 0 92 125 97 98 +43 0 131 92 97 114 +44 0 92 125 98 119 +45 0 66 59 90 78 +46 0 59 90 78 75 +47 0 78 59 75 46 +48 0 78 59 46 63 +49 0 78 59 63 66 +50 0 59 61 90 91 +51 0 46 78 63 68 +52 0 77 102 91 75 +53 0 78 90 103 75 +54 0 103 78 75 96 +55 0 59 90 75 91 +56 0 40 20 28 27 +57 0 28 40 27 59 +58 0 40 27 59 63 +59 0 40 20 27 35 +60 0 27 40 35 63 +61 0 40 20 35 48 +62 0 35 40 48 63 +63 0 48 35 63 54 +64 0 20 27 35 19 +65 0 27 35 19 41 +66 0 35 19 41 29 +67 0 35 19 29 20 +68 0 41 35 29 63 +69 0 41 35 63 27 +70 0 19 41 29 32 +71 0 29 19 32 9 +72 0 19 32 9 10 +73 0 9 19 10 5 +74 0 9 19 5 16 +75 0 19 10 5 13 +76 0 5 19 13 20 +77 0 10 9 5 14 +78 0 19 10 13 30 +79 0 19 10 30 32 +80 0 13 19 30 27 +81 0 30 13 27 38 +82 0 13 27 38 28 +83 0 13 19 27 20 +84 0 27 30 38 46 +85 0 27 30 46 41 +86 0 30 46 41 60 +87 0 46 27 41 63 +88 0 46 41 60 68 +89 0 30 46 60 58 +90 0 30 46 58 38 +91 0 41 30 60 32 +92 0 46 41 68 63 +93 0 27 30 41 19 +94 0 58 30 38 34 +95 0 38 58 34 56 +96 0 38 58 56 75 +97 0 38 58 75 46 +98 0 30 41 19 32 +99 0 58 75 46 60 +100 0 38 27 46 59 +101 0 27 46 59 63 +102 0 41 60 68 32 +103 0 60 30 58 34 +104 0 58 34 56 65 +105 0 58 34 65 60 +106 0 34 38 56 26 +107 0 56 58 65 92 +108 0 38 56 26 62 +109 0 65 56 92 79 +110 0 92 65 79 99 +111 0 92 65 99 89 +112 0 65 79 99 74 +113 0 79 92 99 114 +114 0 65 99 89 74 +115 0 99 79 114 74 +116 0 34 38 26 13 +117 0 30 38 34 13 +118 0 65 56 79 34 +119 0 58 65 92 82 +120 0 65 92 82 89 +121 0 82 65 89 51 +122 0 89 82 51 83 +123 0 82 65 51 60 +124 0 51 82 60 83 +125 0 58 65 82 60 +126 0 82 58 60 96 +127 0 60 82 96 88 +128 0 60 82 88 83 +129 0 82 96 88 130 +130 0 56 34 26 47 +131 0 26 56 47 69 +132 0 10 13 30 34 +133 0 34 26 47 22 +134 0 34 26 22 13 +135 0 26 47 22 39 +136 0 47 22 39 71 +137 0 26 47 39 69 +138 0 10 5 13 7 +139 0 5 13 7 8 +140 0 13 10 7 22 +141 0 47 34 22 42 +142 0 34 22 42 23 +143 0 34 22 23 10 +144 0 22 42 23 21 +145 0 22 42 21 71 +146 0 23 22 21 6 +147 0 22 21 6 11 +148 0 6 22 11 7 +149 0 11 6 7 3 +150 0 6 22 7 10 +151 0 7 6 10 5 +152 0 7 6 5 3 +153 0 22 21 11 39 +154 0 22 21 39 71 +155 0 22 11 7 26 +156 0 23 22 6 10 +157 0 6 23 10 14 +158 0 23 10 14 32 +159 0 22 47 42 71 +160 0 41 29 32 68 +161 0 42 34 23 51 +162 0 47 34 42 79 +163 0 56 34 47 79 +164 0 65 89 51 74 +165 0 41 68 63 29 +166 0 32 9 10 14 +167 0 35 29 63 54 +168 0 10 30 32 23 +169 0 96 60 88 68 +170 0 47 56 79 69 +171 0 56 79 69 97 +172 0 69 56 97 77 +173 0 27 13 20 28 +174 0 23 34 10 30 +175 0 97 92 98 58 +176 0 69 56 77 62 +177 0 59 75 46 38 +178 0 22 11 26 39 +179 0 75 78 46 96 +180 0 66 48 40 63 +181 0 60 46 68 96 +182 0 96 88 130 113 +183 0 88 130 113 83 +184 0 113 88 83 76 +185 0 113 88 76 68 +186 0 88 83 76 60 +187 0 83 113 76 106 +188 0 113 76 106 72 +189 0 58 56 75 97 +190 0 35 29 54 16 +191 0 76 106 72 70 +192 0 124 130 96 119 +193 0 82 88 83 130 +194 0 26 56 69 62 +195 0 29 19 9 16 +196 0 77 102 75 97 +197 0 51 89 83 64 +198 0 58 75 60 96 +199 0 76 88 60 68 +200 0 56 79 97 92 +201 0 79 97 92 114 +202 0 97 56 92 58 +203 0 5 19 20 16 +204 0 21 23 6 12 +205 0 6 21 12 4 +206 0 23 6 12 14 +207 0 12 23 14 31 +208 0 14 12 31 18 +209 0 14 12 18 4 +210 0 12 31 18 21 +211 0 12 18 4 21 +212 0 23 14 31 36 +213 0 14 31 36 52 +214 0 23 14 36 32 +215 0 31 23 36 64 +216 0 12 23 31 21 +217 0 31 36 52 64 +218 0 52 31 64 53 +219 0 12 6 4 14 +220 0 5 13 8 20 +221 0 61 59 28 57 +222 0 61 59 57 91 +223 0 28 61 57 67 +224 0 61 57 67 91 +225 0 57 67 91 77 +226 0 91 57 77 75 +227 0 91 57 75 59 +228 0 57 75 59 38 +229 0 57 77 75 38 +230 0 119 92 89 82 +231 0 89 119 82 130 +232 0 119 92 82 98 +233 0 92 82 98 58 +234 0 96 88 113 68 +235 0 31 14 18 52 +236 0 14 36 32 37 +237 0 36 32 37 76 +238 0 14 36 37 52 +239 0 32 14 37 9 +240 0 37 32 9 29 +241 0 37 32 29 50 +242 0 32 29 50 68 +243 0 29 50 68 63 +244 0 50 68 63 54 +245 0 50 68 54 72 +246 0 50 68 72 76 +247 0 54 50 72 29 +248 0 54 50 29 63 +249 0 37 32 50 76 +250 0 50 72 29 37 +251 0 72 50 76 37 +252 0 13 7 8 26 +253 0 51 89 64 74 +254 0 65 51 60 34 +255 0 65 51 34 42 +256 0 30 60 32 51 +257 0 30 60 51 34 +258 0 38 26 13 25 +259 0 13 38 25 28 +260 0 38 26 25 62 +261 0 38 25 28 57 +262 0 25 28 57 67 +263 0 38 25 57 62 +264 0 25 13 28 8 +265 0 28 25 8 24 +266 0 28 25 24 67 +267 0 25 8 24 15 +268 0 24 25 15 62 +269 0 8 24 15 17 +270 0 24 15 17 33 +271 0 15 17 33 11 +272 0 15 17 11 3 +273 0 24 15 33 62 +274 0 25 8 15 26 +275 0 15 25 26 62 +276 0 17 24 33 44 +277 0 33 17 44 55 +278 0 44 33 55 49 +279 0 44 33 49 24 +280 0 33 49 24 62 +281 0 33 49 62 55 +282 0 25 13 8 26 +283 0 24 25 62 67 +284 0 15 8 17 3 +285 0 49 24 62 67 +286 0 82 96 130 119 +287 0 21 6 11 4 +288 0 42 23 21 31 +289 0 65 79 74 42 +290 0 34 65 42 79 +291 0 83 51 64 36 +292 0 27 28 59 57 +293 0 59 27 57 38 +294 0 27 57 38 28 +295 0 36 23 32 51 +296 0 50 68 76 32 +297 0 33 15 11 26 +298 0 15 11 26 8 +299 0 33 15 26 62 +300 0 20 35 48 16 +301 0 51 30 34 23 +302 0 46 78 68 96 +303 0 75 98 96 82 +304 0 98 96 82 119 +305 0 75 46 60 96 +306 0 79 69 97 114 +307 0 89 82 83 130 +308 0 82 98 58 75 +309 0 98 58 75 97 +310 0 58 82 75 96 +311 0 57 67 77 62 +312 0 77 57 62 38 +313 0 56 77 62 38 +314 0 74 65 42 51 +315 0 79 47 69 73 +316 0 72 54 29 37 +317 0 76 106 70 83 +318 0 70 76 83 36 +319 0 56 97 77 75 +320 0 60 51 83 76 +321 0 42 23 31 64 +322 0 11 7 26 8 +323 0 19 20 16 29 +324 0 56 77 38 75 +325 0 7 5 8 3 +326 0 68 72 76 113 +327 0 6 10 5 14 +328 0 62 33 55 26 +329 0 51 64 36 23 +330 0 11 26 39 55 +331 0 7 22 26 13 +332 0 13 8 20 28 +333 0 37 36 76 70 +334 0 37 36 70 52 +335 0 32 36 51 76 +336 0 79 114 74 80 +337 0 79 114 80 73 +338 0 74 79 80 73 +339 0 20 35 16 29 +340 0 7 11 3 8 +341 0 15 11 8 3 +342 0 57 67 62 25 +343 0 42 47 79 74 +344 0 42 47 74 71 +345 0 74 42 71 53 +346 0 47 79 74 73 +347 0 64 70 83 36 +348 0 51 83 76 36 +349 0 76 72 37 70 +350 0 23 42 51 64 +351 0 60 76 68 32 +352 0 60 32 51 76 +353 0 10 13 34 22 +354 0 47 39 69 73 +355 0 47 39 73 71 +356 0 33 17 55 11 +357 0 36 52 64 70 +358 0 42 51 64 74 +359 0 64 42 74 53 +360 0 32 30 51 23 +361 0 8 5 20 2 +362 0 5 20 2 16 +363 0 2 5 16 9 +364 0 2 5 9 4 +365 0 79 69 114 73 +366 0 8 5 2 3 +367 0 18 31 52 45 +368 0 31 52 45 53 +369 0 18 31 45 53 +370 0 33 55 26 11 +371 0 114 74 80 71 +372 0 74 80 71 73 +373 0 80 114 71 73 +374 0 55 39 73 69 +375 0 69 26 62 55 +376 0 54 29 37 9 +377 0 29 54 16 9 +378 0 35 48 16 43 +379 0 35 48 43 54 +380 0 42 71 53 21 +381 0 53 42 21 31 +382 0 31 42 64 53 +383 0 9 5 14 4 +384 0 6 4 14 5 +385 0 11 6 3 4 +386 0 16 35 43 54 +387 0 47 74 71 73 +388 0 107 114 73 71 +389 0 6 4 5 3 +390 0 31 18 21 53 +391 0 26 39 55 69 +392 0 5 2 3 4 +393 0 2 1 3 4 +394 0 263 268 275 249 +395 0 263 268 249 239 +396 0 263 268 239 251 +397 0 216 198 203 181 +398 0 216 198 181 182 +399 0 216 198 182 218 +400 0 249 263 239 220 +401 0 181 216 182 193 +402 0 203 216 181 221 +403 0 275 263 249 267 +404 0 268 249 239 241 +405 0 198 181 182 161 +406 0 268 275 249 276 +407 0 198 203 181 183 +408 0 272 271 281 266 +409 0 272 271 266 238 +410 0 272 271 238 236 +411 0 271 281 266 280 +412 0 271 266 238 256 +413 0 247 207 208 222 +414 0 207 208 222 185 +415 0 207 208 185 158 +416 0 247 207 222 244 +417 0 222 207 185 197 +418 0 227 210 188 192 +419 0 210 188 192 172 +420 0 210 188 172 169 +421 0 227 210 192 217 +422 0 192 210 172 199 +423 0 115 134 144 132 +424 0 115 134 132 117 +425 0 115 134 117 100 +426 0 134 144 132 170 +427 0 134 132 117 138 +428 0 264 261 277 255 +429 0 264 261 255 230 +430 0 261 277 255 267 +431 0 228 187 190 201 +432 0 187 190 201 146 +433 0 228 187 201 221 +434 0 198 182 218 161 +435 0 277 255 267 275 +436 0 255 267 275 249 +437 0 275 255 249 256 +438 0 255 249 256 214 +439 0 275 255 256 280 +440 0 249 275 256 276 +441 0 277 255 275 280 +442 0 201 228 221 234 +443 0 221 201 234 233 +444 0 201 228 234 190 +445 0 182 216 218 193 +446 0 266 272 238 260 +447 0 208 222 185 200 +448 0 132 115 117 104 +449 0 188 192 172 147 +450 0 222 247 244 253 +451 0 192 227 217 186 +452 0 277 261 273 267 +453 0 211 187 228 221 +454 0 249 263 220 267 +455 0 181 216 193 221 +456 0 238 272 236 260 +457 0 208 185 158 200 +458 0 117 115 100 104 +459 0 188 172 169 147 +460 0 268 249 241 276 +461 0 198 181 161 183 +462 0 271 266 256 280 +463 0 222 207 197 244 +464 0 197 222 244 219 +465 0 192 210 199 217 +466 0 199 192 217 209 +467 0 134 132 138 170 +468 0 255 261 267 231 +469 0 267 255 231 220 +470 0 187 201 221 174 +471 0 201 221 174 193 +472 0 255 261 231 230 +473 0 187 201 174 146 +474 0 263 239 220 246 +475 0 239 268 241 251 +476 0 240 207 247 244 +477 0 248 210 227 217 +478 0 239 249 220 204 +479 0 182 181 193 153 +480 0 249 239 241 204 +481 0 181 182 161 153 +482 0 211 163 187 174 +483 0 261 242 273 231 +484 0 185 207 158 190 +485 0 271 238 236 264 +486 0 172 210 169 226 +487 0 134 117 100 143 +488 0 238 271 256 264 +489 0 271 256 264 280 +490 0 207 185 197 190 +491 0 197 207 190 240 +492 0 210 172 199 226 +493 0 199 210 226 248 +494 0 117 134 138 143 +495 0 134 138 143 170 +496 0 266 272 260 282 +497 0 132 115 104 129 +498 0 281 272 266 282 +499 0 188 227 192 202 +500 0 208 222 200 252 +501 0 188 192 147 202 +502 0 208 247 222 252 +503 0 144 115 132 129 +504 0 277 264 255 280 +505 0 143 163 191 165 +506 0 143 163 165 126 +507 0 266 238 256 241 +508 0 172 192 199 167 +509 0 265 242 226 229 +510 0 242 226 229 195 +511 0 185 222 197 219 +512 0 132 117 138 123 +513 0 255 267 249 220 +514 0 238 266 260 235 +515 0 222 185 200 219 +516 0 117 132 104 123 +517 0 192 172 147 167 +518 0 222 244 219 253 +519 0 220 263 246 267 +520 0 217 209 237 199 +521 0 217 192 186 178 +522 0 191 143 165 183 +523 0 165 191 183 203 +524 0 183 165 203 181 +525 0 165 203 181 174 +526 0 181 165 174 153 +527 0 203 181 174 221 +528 0 165 191 203 163 +529 0 165 203 174 163 +530 0 183 165 181 161 +531 0 226 265 229 237 +532 0 265 229 237 259 +533 0 229 237 259 225 +534 0 265 229 259 242 +535 0 234 201 190 197 +536 0 234 201 197 233 +537 0 201 190 197 146 +538 0 237 217 199 248 +539 0 174 165 163 126 +540 0 249 220 204 214 +541 0 181 193 153 174 +542 0 181 193 174 221 +543 0 261 242 231 230 +544 0 234 243 233 197 +545 0 163 187 174 146 +546 0 238 266 235 241 +547 0 143 165 183 138 +548 0 165 183 138 161 +549 0 143 165 138 126 +550 0 229 226 237 199 +551 0 237 229 199 225 +552 0 229 226 199 195 +553 0 229 259 242 231 +554 0 229 259 231 225 +555 0 242 229 231 195 +556 0 220 239 204 194 +557 0 193 182 153 194 +558 0 249 256 214 241 +559 0 249 256 241 276 +560 0 165 181 161 153 +561 0 265 259 273 242 +562 0 265 226 248 237 +563 0 240 244 234 197 +564 0 244 234 197 243 +565 0 240 234 228 190 +566 0 259 267 273 231 +567 0 211 203 191 163 +568 0 170 143 191 183 +569 0 211 221 203 174 +570 0 239 263 251 246 +571 0 249 255 220 214 +572 0 241 249 204 214 +573 0 192 199 167 209 +574 0 138 132 123 160 +575 0 138 132 160 170 +576 0 266 260 235 278 +577 0 239 241 204 212 +578 0 182 161 153 159 +579 0 260 238 235 215 +580 0 259 267 231 246 +581 0 199 172 167 168 +582 0 117 138 123 118 +583 0 275 256 276 280 +584 0 256 264 280 255 +585 0 256 264 255 214 +586 0 190 197 240 234 +587 0 226 199 248 237 +588 0 138 143 170 183 +589 0 192 227 186 202 +590 0 182 218 161 159 +591 0 197 207 240 244 +592 0 199 210 248 217 +593 0 182 218 159 194 +594 0 261 273 267 231 +595 0 211 187 221 174 +596 0 266 260 278 282 +597 0 100 117 104 93 +598 0 100 117 93 118 +599 0 236 238 260 215 +600 0 172 169 147 136 +601 0 172 169 136 168 +602 0 218 182 193 194 +603 0 185 158 200 150 +604 0 185 158 150 141 +605 0 185 158 141 146 +606 0 236 238 215 214 +607 0 132 123 160 135 +608 0 160 132 135 144 +609 0 160 132 144 170 +610 0 266 235 241 278 +611 0 220 239 194 246 +612 0 239 241 212 251 +613 0 192 217 209 178 +614 0 241 268 276 269 +615 0 132 104 123 135 +616 0 132 104 135 129 +617 0 147 192 167 186 +618 0 147 192 186 202 +619 0 104 117 123 93 +620 0 172 147 167 136 +621 0 222 247 253 252 +622 0 216 193 221 233 +623 0 216 193 233 218 +624 0 255 231 220 214 +625 0 255 231 214 230 +626 0 174 201 193 162 +627 0 174 201 162 146 +628 0 185 197 190 146 +629 0 138 117 143 126 +630 0 256 238 264 214 +631 0 172 199 226 195 +632 0 170 138 183 160 +633 0 138 183 160 179 +634 0 266 281 282 278 +635 0 132 144 129 135 +636 0 237 209 225 199 +637 0 117 93 118 123 +638 0 136 172 168 167 +639 0 239 204 194 212 +640 0 117 138 118 126 +641 0 199 172 168 195 +642 0 200 185 150 219 +643 0 153 182 159 194 +644 0 281 266 280 276 +645 0 281 266 276 278 +646 0 266 276 278 241 +647 0 244 197 219 243 +648 0 219 244 243 257 +649 0 243 219 257 212 +650 0 204 220 194 171 +651 0 212 239 251 194 +652 0 239 251 194 246 +653 0 100 117 118 126 +654 0 172 169 168 195 +655 0 193 174 162 153 +656 0 221 201 233 193 +657 0 266 280 276 256 +658 0 276 266 256 241 +659 0 198 179 183 161 +660 0 198 179 161 218 +661 0 231 220 214 171 +662 0 238 235 215 213 +663 0 238 235 213 241 +664 0 235 213 241 212 +665 0 235 215 213 196 +666 0 213 235 196 212 +667 0 231 267 220 246 +668 0 255 264 230 214 +669 0 220 231 246 171 +670 0 167 199 168 184 +671 0 138 123 118 161 +672 0 235 260 215 196 +673 0 241 204 212 213 +674 0 241 204 213 214 +675 0 204 213 214 157 +676 0 204 213 157 212 +677 0 161 153 159 122 +678 0 177 155 202 152 +679 0 282 279 283 270 +680 0 150 185 141 162 +681 0 138 165 161 118 +682 0 211 203 163 174 +683 0 259 273 242 231 +684 0 185 141 162 146 +685 0 141 162 146 126 +686 0 204 220 171 214 +687 0 253 222 252 200 +688 0 253 222 200 219 +689 0 219 244 257 253 +690 0 264 230 214 236 +691 0 231 214 230 195 +692 0 93 118 123 122 +693 0 118 123 122 161 +694 0 168 136 167 128 +695 0 129 110 105 86 +696 0 254 258 252 206 +697 0 241 235 212 232 +698 0 179 183 161 138 +699 0 272 260 282 270 +700 0 272 260 270 236 +701 0 200 208 252 206 +702 0 200 208 206 158 +703 0 115 104 129 86 +704 0 115 104 86 100 +705 0 147 188 202 152 +706 0 147 188 152 169 +707 0 138 165 118 126 +708 0 213 214 157 215 +709 0 204 194 212 156 +710 0 220 194 171 246 +711 0 167 199 184 209 +712 0 123 138 160 179 +713 0 161 153 122 118 +714 0 194 204 171 157 +715 0 159 161 122 142 +716 0 192 186 178 167 +717 0 197 219 243 162 +718 0 259 225 246 231 +719 0 153 159 122 133 +720 0 241 235 232 269 +721 0 232 241 269 212 +722 0 241 235 269 278 +723 0 179 148 160 123 +724 0 201 233 193 162 +725 0 199 168 184 229 +726 0 184 199 229 225 +727 0 199 168 229 195 +728 0 241 268 269 251 +729 0 158 141 146 108 +730 0 172 169 195 226 +731 0 100 117 126 143 +732 0 168 167 184 128 +733 0 123 104 93 91 +734 0 147 167 136 125 +735 0 158 150 141 108 +736 0 123 122 161 142 +737 0 138 123 161 179 +738 0 197 185 219 162 +739 0 197 185 162 146 +740 0 158 185 190 146 +741 0 238 236 264 214 +742 0 160 148 135 123 +743 0 186 147 202 155 +744 0 256 238 214 213 +745 0 214 256 213 241 +746 0 256 238 213 241 +747 0 209 189 225 184 +748 0 225 209 184 199 +749 0 159 161 142 189 +750 0 235 232 269 278 +751 0 204 194 156 157 +752 0 162 193 153 173 +753 0 193 153 173 194 +754 0 171 204 214 157 +755 0 212 204 156 157 +756 0 141 150 162 120 +757 0 162 141 120 126 +758 0 153 159 133 194 +759 0 93 118 122 94 +760 0 232 269 278 274 +761 0 153 122 118 94 +762 0 104 135 129 110 +763 0 238 214 213 215 +764 0 257 219 253 205 +765 0 123 161 179 142 +766 0 161 179 142 189 +767 0 179 142 189 148 +768 0 179 142 148 123 +769 0 229 184 225 231 +770 0 278 279 282 260 +771 0 162 174 146 126 +772 0 126 146 163 174 +773 0 242 230 195 231 +774 0 178 189 209 167 +775 0 123 122 142 77 +776 0 93 100 118 84 +777 0 169 136 168 149 +778 0 243 251 233 173 +779 0 173 193 194 233 +780 0 252 253 200 258 +781 0 141 146 108 126 +782 0 142 189 148 140 +783 0 260 235 278 250 +784 0 260 235 250 196 +785 0 278 260 250 279 +786 0 122 153 133 94 +787 0 122 159 142 128 +788 0 159 122 133 128 +789 0 197 201 146 162 +790 0 197 201 162 233 +791 0 194 212 156 173 +792 0 156 194 173 133 +793 0 212 156 173 166 +794 0 194 212 173 251 +795 0 173 156 133 120 +796 0 156 173 166 120 +797 0 123 93 122 77 +798 0 229 184 231 168 +799 0 232 269 274 262 +800 0 168 136 128 127 +801 0 174 162 153 118 +802 0 184 167 209 189 +803 0 195 149 169 168 +804 0 100 84 126 118 +805 0 162 193 173 233 +806 0 104 135 110 91 +807 0 110 104 91 86 +808 0 104 91 86 67 +809 0 269 232 212 257 +810 0 136 147 125 131 +811 0 173 212 166 219 +812 0 214 231 171 168 +813 0 93 100 84 67 +814 0 169 136 149 131 +815 0 142 159 189 167 +816 0 186 147 155 137 +817 0 158 200 150 139 +818 0 104 100 93 67 +819 0 169 147 136 131 +820 0 153 173 194 133 +821 0 178 192 167 209 +822 0 260 236 215 223 +823 0 104 135 91 123 +824 0 142 148 123 102 +825 0 269 232 257 262 +826 0 253 200 258 205 +827 0 200 258 205 206 +828 0 205 200 206 139 +829 0 147 167 125 137 +830 0 167 147 186 178 +831 0 253 200 205 219 +832 0 104 93 91 67 +833 0 136 167 128 125 +834 0 241 269 212 251 +835 0 274 245 279 250 +836 0 274 245 250 224 +837 0 245 279 250 260 +838 0 250 245 260 215 +839 0 245 260 215 223 +840 0 245 250 224 175 +841 0 250 274 224 232 +842 0 250 274 232 278 +843 0 224 250 232 196 +844 0 279 274 250 278 +845 0 245 279 260 270 +846 0 260 245 270 223 +847 0 250 245 215 175 +848 0 232 250 278 235 +849 0 232 250 235 196 +850 0 155 125 137 147 +851 0 155 125 147 152 +852 0 125 147 152 131 +853 0 260 250 215 196 +854 0 218 161 159 189 +855 0 276 241 269 278 +856 0 161 153 118 165 +857 0 243 233 197 162 +858 0 215 213 196 157 +859 0 196 213 212 157 +860 0 93 118 94 84 +861 0 165 174 153 118 +862 0 168 136 127 149 +863 0 235 196 212 232 +864 0 156 194 133 171 +865 0 133 156 171 157 +866 0 156 194 171 157 +867 0 141 150 120 108 +868 0 161 179 189 218 +869 0 245 215 175 223 +870 0 147 186 178 137 +871 0 214 171 157 168 +872 0 252 200 206 258 +873 0 202 147 152 155 +874 0 260 282 270 279 +875 0 104 129 86 110 +876 0 194 133 171 159 +877 0 133 171 159 128 +878 0 150 158 139 108 +879 0 193 233 218 194 +880 0 214 230 195 180 +881 0 116 91 110 135 +882 0 258 205 262 253 +883 0 153 162 173 120 +884 0 153 173 133 120 +885 0 171 194 159 246 +886 0 148 142 140 102 +887 0 150 185 162 219 +888 0 212 156 166 196 +889 0 212 156 196 157 +890 0 166 212 196 232 +891 0 184 168 128 171 +892 0 184 168 171 231 +893 0 189 225 184 159 +894 0 167 184 128 159 +895 0 236 215 223 176 +896 0 236 215 176 180 +897 0 176 236 180 223 +898 0 173 194 251 233 +899 0 274 224 232 262 +900 0 148 135 123 112 +901 0 148 135 112 116 +902 0 123 148 112 102 +903 0 112 148 116 102 +904 0 116 112 102 91 +905 0 116 112 91 135 +906 0 112 91 135 123 +907 0 112 91 123 77 +908 0 112 102 91 77 +909 0 225 184 159 246 +910 0 225 184 246 231 +911 0 231 229 168 195 +912 0 165 174 118 126 +913 0 212 173 251 243 +914 0 156 166 196 109 +915 0 120 141 108 126 +916 0 225 218 246 159 +917 0 84 126 118 94 +918 0 195 149 168 164 +919 0 168 195 164 214 +920 0 195 149 164 180 +921 0 164 195 180 214 +922 0 149 164 180 127 +923 0 149 164 127 168 +924 0 164 127 168 157 +925 0 164 127 157 180 +926 0 157 164 180 214 +927 0 157 164 214 168 +928 0 171 184 231 246 +929 0 215 223 176 175 +930 0 219 257 212 232 +931 0 167 147 178 137 +932 0 137 116 140 102 +933 0 140 137 102 178 +934 0 116 140 102 148 +935 0 128 168 127 171 +936 0 133 156 157 111 +937 0 136 128 127 97 +938 0 136 128 97 125 +939 0 257 251 243 212 +940 0 224 250 196 175 +941 0 156 196 157 109 +942 0 128 184 171 159 +943 0 184 171 159 246 +944 0 133 171 128 127 +945 0 176 215 175 157 +946 0 133 156 111 120 +947 0 231 214 195 168 +948 0 142 189 140 178 +949 0 142 189 178 167 +950 0 230 214 236 180 +951 0 260 270 236 223 +952 0 104 86 100 67 +953 0 206 200 158 139 +954 0 152 147 169 131 +955 0 125 102 137 167 +956 0 218 159 194 246 +957 0 173 212 219 243 +958 0 136 127 149 114 +959 0 97 136 125 131 +960 0 133 122 94 95 +961 0 133 122 95 128 +962 0 95 133 128 127 +963 0 122 95 128 142 +964 0 122 93 94 95 +965 0 171 133 157 127 +966 0 162 173 120 166 +967 0 219 243 162 173 +968 0 150 200 219 205 +969 0 150 200 205 139 +970 0 233 243 173 162 +971 0 250 215 196 175 +972 0 215 196 175 157 +973 0 194 251 233 218 +974 0 150 162 120 166 +975 0 120 150 166 101 +976 0 156 157 111 109 +977 0 162 173 166 219 +978 0 215 176 180 157 +979 0 93 123 91 77 +980 0 174 118 126 162 +981 0 184 189 159 167 +982 0 232 224 196 166 +983 0 180 176 223 154 +984 0 180 176 154 121 +985 0 180 176 121 157 +986 0 84 93 67 62 +987 0 136 149 131 114 +988 0 127 136 97 114 +989 0 219 257 232 205 +990 0 84 108 126 94 +991 0 153 162 120 118 +992 0 225 218 159 189 +993 0 118 153 94 120 +994 0 140 142 178 102 +995 0 97 136 131 114 +996 0 176 154 121 175 +997 0 212 166 219 232 +998 0 176 223 154 175 +999 0 224 232 262 205 +1000 0 251 194 246 218 +1001 0 94 93 84 62 +1002 0 126 118 94 120 +1003 0 94 133 95 111 +1004 0 150 162 166 219 +1005 0 166 150 219 205 +1006 0 128 95 127 97 +1007 0 128 95 97 102 +1008 0 257 251 212 269 +1009 0 153 133 94 120 +1010 0 166 150 205 145 +1011 0 166 150 145 101 +1012 0 176 121 157 175 +1013 0 133 94 120 111 +1014 0 159 142 128 167 +1015 0 205 166 145 224 +1016 0 171 157 168 127 +1017 0 166 156 120 111 +1018 0 122 93 95 77 +1019 0 95 122 77 142 +1020 0 93 95 77 62 +1021 0 95 77 62 69 +1022 0 95 77 69 97 +1023 0 91 93 77 67 +1024 0 150 205 145 139 +1025 0 180 149 127 114 +1026 0 205 262 253 257 +1027 0 224 196 166 145 +1028 0 196 166 145 109 +1029 0 214 157 215 180 +1030 0 196 224 175 145 +1031 0 125 97 102 128 +1032 0 166 156 111 109 +1033 0 215 236 214 180 +1034 0 93 94 95 62 +1035 0 150 120 108 101 +1036 0 145 166 101 109 +1037 0 94 120 111 81 +1038 0 94 120 81 108 +1039 0 94 120 108 126 +1040 0 95 77 97 102 +1041 0 67 49 84 62 +1042 0 94 95 62 111 +1043 0 121 180 157 127 +1044 0 157 121 127 111 +1045 0 121 180 127 114 +1046 0 77 93 62 67 +1047 0 150 145 101 139 +1048 0 112 102 77 123 +1049 0 178 142 167 102 +1050 0 196 175 157 109 +1051 0 95 77 102 142 +1052 0 157 121 111 109 +1053 0 120 81 108 101 +1054 0 120 81 101 111 +1055 0 81 101 111 109 +1056 0 157 133 111 127 +1057 0 118 126 162 120 +1058 0 95 128 142 102 +1059 0 154 180 121 114 +1060 0 121 111 109 73 +1061 0 142 128 167 102 +1062 0 137 102 178 167 +1063 0 133 95 111 127 +1064 0 101 111 109 166 +1065 0 69 95 97 127 +1066 0 81 101 109 55 +1067 0 84 108 94 81 +1068 0 62 95 69 111 +1069 0 175 196 145 109 +1070 0 81 101 55 87 +1071 0 81 101 87 108 +1072 0 49 84 62 81 +1073 0 167 128 125 102 +1074 0 111 81 109 55 +1075 0 121 127 111 69 +1076 0 84 94 62 81 +1077 0 94 62 81 111 +1078 0 232 224 166 205 +1079 0 120 166 111 101 +1080 0 232 257 262 205 +1081 0 219 166 205 232 +1082 0 101 150 139 108 +1083 0 87 81 108 49 +1084 0 87 101 139 108 +1085 0 49 108 84 81 +1086 0 127 121 114 69 +1087 0 62 49 81 55 +1088 0 69 95 127 111 +1089 0 123 142 102 77 +1090 0 97 69 127 114 +1091 0 157 121 109 175 +1092 0 81 62 55 69 +1093 0 111 109 73 55 +1094 0 121 109 175 154 +1095 0 111 81 55 69 +1096 0 109 121 73 154 +1097 0 81 62 69 111 +1098 0 55 81 87 44 +1099 0 81 87 44 49 +1100 0 55 81 44 49 +1101 0 154 107 114 121 +1102 0 154 107 121 73 +1103 0 111 121 69 73 +1104 0 107 114 121 73 +1105 0 55 69 73 111 +1106 0 121 69 73 114 +End Elements + + + +Begin Conditions Condition3D +1 0 151 155 177 +2 0 152 151 177 +3 0 105 85 86 +4 0 85 105 110 +5 0 124 137 155 +6 0 90 110 116 +7 0 155 151 124 +8 0 90 85 110 +9 0 137 124 103 +10 0 124 96 103 +11 0 103 116 137 +12 0 66 61 85 +13 0 85 90 66 +14 0 131 119 152 +15 0 86 85 61 +16 0 151 152 119 +17 0 116 103 90 +18 0 66 40 61 +19 0 28 61 40 +20 0 131 99 119 +21 0 114 99 131 +22 0 89 119 99 +23 0 130 124 151 +24 0 151 119 130 +25 0 61 67 86 +26 0 90 78 66 +27 0 63 66 78 +28 0 78 68 63 +29 0 78 90 103 +30 0 96 78 103 +31 0 40 20 28 +32 0 48 20 40 +33 0 63 54 48 +34 0 99 74 89 +35 0 114 74 99 +36 0 21 39 11 +37 0 21 71 39 +38 0 66 48 40 +39 0 63 48 66 +40 0 130 113 96 +41 0 130 83 113 +42 0 106 113 83 +43 0 106 72 113 +44 0 106 70 72 +45 0 124 130 96 +46 0 89 64 83 +47 0 18 4 14 +48 0 18 21 4 +49 0 64 53 52 +50 0 67 61 28 +51 0 130 119 89 +52 0 113 68 96 +53 0 14 52 18 +54 0 37 52 14 +55 0 14 9 37 +56 0 68 54 63 +57 0 68 72 54 +58 0 89 74 64 +59 0 8 24 28 +60 0 24 67 28 +61 0 17 24 8 +62 0 17 3 11 +63 0 44 24 17 +64 0 17 55 44 +65 0 49 24 44 +66 0 8 3 17 +67 0 67 24 49 +68 0 11 4 21 +69 0 48 16 20 +70 0 78 96 68 +71 0 83 130 89 +72 0 37 54 72 +73 0 106 83 70 +74 0 113 72 68 +75 0 39 55 11 +76 0 8 28 20 +77 0 70 52 37 +78 0 71 53 74 +79 0 64 70 83 +80 0 72 70 37 +81 0 39 71 73 +82 0 17 11 55 +83 0 52 70 64 +84 0 74 53 64 +85 0 20 2 8 +86 0 20 16 2 +87 0 16 9 2 +88 0 9 4 2 +89 0 2 3 8 +90 0 52 45 18 +91 0 52 53 45 +92 0 45 53 18 +93 0 71 74 114 +94 0 55 39 73 +95 0 37 9 54 +96 0 54 9 16 +97 0 48 43 16 +98 0 48 54 43 +99 0 71 21 53 +100 0 14 4 9 +101 0 3 4 11 +102 0 43 54 16 +103 0 73 71 107 +104 0 71 114 107 +105 0 18 53 21 +106 0 2 1 3 +107 0 4 1 2 +108 0 1 4 3 +109 0 263 268 275 +110 0 251 268 263 +111 0 216 198 203 +112 0 218 198 216 +113 0 221 216 203 +114 0 267 263 275 +115 0 276 275 268 +116 0 183 203 198 +117 0 272 271 281 +118 0 236 271 272 +119 0 280 281 271 +120 0 247 207 208 +121 0 158 208 207 +122 0 227 210 188 +123 0 169 188 210 +124 0 115 134 144 +125 0 100 134 115 +126 0 170 144 134 +127 0 264 261 277 +128 0 230 261 264 +129 0 228 187 190 +130 0 146 190 187 +131 0 267 275 277 +132 0 275 280 277 +133 0 228 234 221 +134 0 234 233 221 +135 0 247 253 244 +136 0 227 186 217 +137 0 273 267 277 +138 0 277 261 273 +139 0 211 187 228 +140 0 228 221 211 +141 0 240 207 247 +142 0 247 244 240 +143 0 227 217 248 +144 0 248 210 227 +145 0 211 163 187 +146 0 261 242 273 +147 0 207 190 158 +148 0 236 264 271 +149 0 210 226 169 +150 0 100 143 134 +151 0 264 280 271 +152 0 207 240 190 +153 0 210 248 226 +154 0 143 170 134 +155 0 282 272 281 +156 0 202 227 188 +157 0 252 247 208 +158 0 129 115 144 +159 0 280 264 277 +160 0 143 163 191 +161 0 126 163 143 +162 0 265 242 226 +163 0 195 226 242 +164 0 263 267 246 +165 0 217 209 237 +166 0 186 178 217 +167 0 191 203 183 +168 0 237 259 265 +169 0 237 225 259 +170 0 248 217 237 +171 0 230 242 261 +172 0 234 243 233 +173 0 146 187 163 +174 0 265 259 273 +175 0 273 242 265 +176 0 248 237 265 +177 0 265 226 248 +178 0 240 244 234 +179 0 243 234 244 +180 0 228 190 240 +181 0 240 234 228 +182 0 259 267 273 +183 0 191 163 211 +184 0 211 203 191 +185 0 170 143 191 +186 0 191 183 170 +187 0 211 221 203 +188 0 263 246 251 +189 0 246 267 259 +190 0 276 280 275 +191 0 227 202 186 +192 0 135 144 160 +193 0 144 170 160 +194 0 217 178 209 +195 0 268 269 276 +196 0 247 252 253 +197 0 221 233 216 +198 0 233 218 216 +199 0 183 160 170 +200 0 183 179 160 +201 0 281 278 282 +202 0 144 135 129 +203 0 237 209 225 +204 0 280 276 281 +205 0 276 278 281 +206 0 244 257 243 +207 0 198 179 183 +208 0 218 179 198 +209 0 177 155 202 +210 0 202 152 177 +211 0 282 279 283 +212 0 279 270 283 +213 0 283 270 282 +214 0 244 253 257 +215 0 236 230 264 +216 0 105 86 129 +217 0 129 110 105 +218 0 252 206 254 +219 0 254 258 252 +220 0 206 258 254 +221 0 282 270 272 +222 0 270 236 272 +223 0 208 206 252 +224 0 208 158 206 +225 0 129 86 115 +226 0 86 100 115 +227 0 188 152 202 +228 0 188 169 152 +229 0 259 225 246 +230 0 179 148 160 +231 0 268 251 269 +232 0 146 108 158 +233 0 169 226 195 +234 0 126 143 100 +235 0 190 146 158 +236 0 160 148 135 +237 0 202 155 186 +238 0 209 189 225 +239 0 269 274 278 +240 0 135 110 129 +241 0 189 148 179 +242 0 278 279 282 +243 0 126 146 163 +244 0 242 230 195 +245 0 178 189 209 +246 0 243 251 233 +247 0 258 253 252 +248 0 146 126 108 +249 0 189 140 148 +250 0 269 262 274 +251 0 195 149 169 +252 0 100 84 126 +253 0 100 67 84 +254 0 149 131 169 +255 0 155 137 186 +256 0 257 262 269 +257 0 258 206 205 +258 0 206 139 205 +259 0 274 245 279 +260 0 224 245 274 +261 0 224 175 245 +262 0 278 274 279 +263 0 270 279 245 +264 0 245 223 270 +265 0 269 278 276 +266 0 179 218 189 +267 0 175 223 245 +268 0 186 137 178 +269 0 158 108 139 +270 0 230 180 195 +271 0 110 135 116 +272 0 262 253 258 +273 0 258 205 262 +274 0 236 223 180 +275 0 262 224 274 +276 0 116 135 148 +277 0 225 218 246 +278 0 180 149 195 +279 0 137 116 140 +280 0 178 137 140 +281 0 148 140 116 +282 0 257 251 243 +283 0 189 178 140 +284 0 236 180 230 +285 0 270 223 236 +286 0 86 67 100 +287 0 158 139 206 +288 0 169 131 152 +289 0 251 218 233 +290 0 223 154 180 +291 0 149 114 131 +292 0 84 108 126 +293 0 189 218 225 +294 0 223 175 154 +295 0 262 205 224 +296 0 246 218 251 +297 0 269 251 257 +298 0 145 224 205 +299 0 205 139 145 +300 0 114 149 180 +301 0 262 257 253 +302 0 224 145 175 +303 0 101 109 145 +304 0 67 49 84 +305 0 145 139 101 +306 0 114 180 154 +307 0 101 55 109 +308 0 145 109 175 +309 0 101 87 55 +310 0 108 49 87 +311 0 139 108 87 +312 0 87 101 139 +313 0 49 108 84 +314 0 109 55 73 +315 0 109 154 175 +316 0 73 154 109 +317 0 87 44 55 +318 0 87 49 44 +319 0 154 107 114 +320 0 73 107 154 +End Conditions + + + +Begin NodalData FLAG_VARIABLE +1 0 2.00000e+00 +2 0 2.00000e+00 +3 0 2.00000e+00 +4 0 2.00000e+00 +8 0 2.00000e+00 +9 0 2.00000e+00 +14 0 2.00000e+00 +16 0 2.00000e+00 +17 0 2.00000e+00 +18 0 2.00000e+00 +20 0 2.00000e+00 +24 0 2.00000e+00 +28 0 2.00000e+00 +37 0 2.00000e+00 +40 0 2.00000e+00 +43 0 1.00000e+00 +44 0 2.00000e+00 +45 0 2.00000e+00 +48 0 1.00000e+00 +49 0 2.00000e+00 +52 0 2.00000e+00 +53 0 2.00000e+00 +54 0 1.00000e+00 +61 0 2.00000e+00 +63 0 1.00000e+00 +64 0 2.00000e+00 +66 0 1.00000e+00 +67 0 2.00000e+00 +68 0 1.00000e+00 +70 0 2.00000e+00 +71 0 2.00000e+00 +72 0 1.00000e+00 +74 0 2.00000e+00 +78 0 1.00000e+00 +83 0 2.00000e+00 +84 0 2.00000e+00 +85 0 1.00000e+00 +86 0 2.00000e+00 +87 0 2.00000e+00 +89 0 2.00000e+00 +90 0 1.00000e+00 +96 0 1.00000e+00 +99 0 2.00000e+00 +100 0 2.00000e+00 +103 0 1.00000e+00 +105 0 1.00000e+00 +106 0 1.00000e+00 +107 0 2.00000e+00 +108 0 2.00000e+00 +110 0 1.00000e+00 +113 0 1.00000e+00 +114 0 2.00000e+00 +115 0 2.00000e+00 +116 0 1.00000e+00 +119 0 2.00000e+00 +124 0 1.00000e+00 +126 0 2.00000e+00 +129 0 1.00000e+00 +130 0 1.00000e+00 +131 0 2.00000e+00 +134 0 2.00000e+00 +135 0 1.00000e+00 +137 0 1.00000e+00 +139 0 2.00000e+00 +140 0 1.00000e+00 +143 0 2.00000e+00 +144 0 1.00000e+00 +146 0 2.00000e+00 +148 0 1.00000e+00 +149 0 2.00000e+00 +151 0 1.00000e+00 +152 0 2.00000e+00 +154 0 2.00000e+00 +155 0 1.00000e+00 +158 0 2.00000e+00 +160 0 1.00000e+00 +163 0 2.00000e+00 +169 0 2.00000e+00 +170 0 1.00000e+00 +177 0 1.00000e+00 +178 0 1.00000e+00 +179 0 1.00000e+00 +180 0 2.00000e+00 +183 0 1.00000e+00 +186 0 1.00000e+00 +187 0 2.00000e+00 +188 0 2.00000e+00 +189 0 1.00000e+00 +190 0 2.00000e+00 +191 0 1.00000e+00 +195 0 2.00000e+00 +198 0 1.00000e+00 +202 0 1.00000e+00 +203 0 1.00000e+00 +206 0 2.00000e+00 +207 0 2.00000e+00 +208 0 2.00000e+00 +209 0 1.00000e+00 +210 0 2.00000e+00 +211 0 1.00000e+00 +216 0 1.00000e+00 +217 0 1.00000e+00 +218 0 1.00000e+00 +221 0 1.00000e+00 +223 0 2.00000e+00 +225 0 1.00000e+00 +226 0 2.00000e+00 +227 0 1.00000e+00 +228 0 1.00000e+00 +230 0 2.00000e+00 +233 0 1.00000e+00 +234 0 1.00000e+00 +236 0 2.00000e+00 +237 0 1.00000e+00 +240 0 1.00000e+00 +242 0 2.00000e+00 +243 0 1.00000e+00 +244 0 1.00000e+00 +246 0 1.00000e+00 +247 0 1.00000e+00 +248 0 1.00000e+00 +251 0 1.00000e+00 +252 0 1.00000e+00 +253 0 1.00000e+00 +254 0 1.00000e+00 +257 0 1.00000e+00 +258 0 1.00000e+00 +259 0 1.00000e+00 +261 0 2.00000e+00 +262 0 1.00000e+00 +263 0 1.00000e+00 +264 0 2.00000e+00 +265 0 1.00000e+00 +267 0 1.00000e+00 +268 0 1.00000e+00 +269 0 1.00000e+00 +270 0 2.00000e+00 +271 0 2.00000e+00 +272 0 2.00000e+00 +273 0 1.00000e+00 +274 0 1.00000e+00 +275 0 1.00000e+00 +276 0 1.00000e+00 +277 0 1.00000e+00 +278 0 1.00000e+00 +279 0 1.00000e+00 +280 0 1.00000e+00 +281 0 1.00000e+00 +282 0 1.00000e+00 +283 0 1.00000e+00 +End NodalData + + + + + diff --git a/applications/FSIapplication/tests/RedistributionTest/square10.mdpa b/applications/FSIapplication/tests/RedistributionTest/square10.mdpa new file mode 100644 index 000000000000..7994dca78554 --- /dev/null +++ b/applications/FSIapplication/tests/RedistributionTest/square10.mdpa @@ -0,0 +1,337 @@ +Begin ModelPartData +// VARIABLE_NAME value +End ModelPartData + +Begin Properties 0 +End Properties + +Begin Properties 1 +End Properties + +Begin Nodes + 1 0.0000000000 1.0000000000 0.0000000000 + 2 0.1000000000 1.0000000000 0.0000000000 + 3 0.0000000000 0.9000000000 0.0000000000 + 4 0.1000000000 0.9000000000 0.0000000000 + 5 0.2000000000 1.0000000000 0.0000000000 + 6 0.0000000000 0.8000000000 0.0000000000 + 7 0.2000000000 0.9000000000 0.0000000000 + 8 0.1000000000 0.8000000000 0.0000000000 + 9 0.2000000000 0.8000000000 0.0000000000 + 10 0.3000000000 1.0000000000 0.0000000000 + 11 0.0000000000 0.7000000000 0.0000000000 + 12 0.1000000000 0.7000000000 0.0000000000 + 13 0.3000000000 0.9000000000 0.0000000000 + 14 0.3000000000 0.8000000000 0.0000000000 + 15 0.2000000000 0.7000000000 0.0000000000 + 16 0.4000000000 1.0000000000 0.0000000000 + 17 0.0000000000 0.6000000000 0.0000000000 + 18 0.1000000000 0.6000000000 0.0000000000 + 19 0.4000000000 0.9000000000 0.0000000000 + 20 0.3000000000 0.7000000000 0.0000000000 + 21 0.2000000000 0.6000000000 0.0000000000 + 22 0.4000000000 0.8000000000 0.0000000000 + 23 0.3000000000 0.6000000000 0.0000000000 + 24 0.5000000000 1.0000000000 0.0000000000 + 25 0.0000000000 0.5000000000 0.0000000000 + 26 0.4000000000 0.7000000000 0.0000000000 + 27 0.1000000000 0.5000000000 0.0000000000 + 28 0.5000000000 0.9000000000 0.0000000000 + 29 0.2000000000 0.5000000000 0.0000000000 + 30 0.5000000000 0.8000000000 0.0000000000 + 31 0.4000000000 0.6000000000 0.0000000000 + 32 0.3000000000 0.5000000000 0.0000000000 + 33 0.5000000000 0.7000000000 0.0000000000 + 34 0.6000000000 1.0000000000 0.0000000000 + 35 0.0000000000 0.4000000000 0.0000000000 + 36 0.1000000000 0.4000000000 0.0000000000 + 37 0.6000000000 0.9000000000 0.0000000000 + 38 0.2000000000 0.4000000000 0.0000000000 + 39 0.6000000000 0.8000000000 0.0000000000 + 40 0.4000000000 0.5000000000 0.0000000000 + 41 0.5000000000 0.6000000000 0.0000000000 + 42 0.3000000000 0.4000000000 0.0000000000 + 43 0.6000000000 0.7000000000 0.0000000000 + 44 0.7000000000 1.0000000000 0.0000000000 + 45 0.0000000000 0.3000000000 0.0000000000 + 46 0.7000000000 0.9000000000 0.0000000000 + 47 0.1000000000 0.3000000000 0.0000000000 + 48 0.5000000000 0.5000000000 0.0000000000 + 49 0.6000000000 0.6000000000 0.0000000000 + 50 0.4000000000 0.4000000000 0.0000000000 + 51 0.2000000000 0.3000000000 0.0000000000 + 52 0.7000000000 0.8000000000 0.0000000000 + 53 0.3000000000 0.3000000000 0.0000000000 + 54 0.7000000000 0.7000000000 0.0000000000 + 55 0.5000000000 0.4000000000 0.0000000000 + 56 0.6000000000 0.5000000000 0.0000000000 + 57 0.8000000000 1.0000000000 0.0000000000 + 58 0.0000000000 0.2000000000 0.0000000000 + 59 0.4000000000 0.3000000000 0.0000000000 + 60 0.7000000000 0.6000000000 0.0000000000 + 61 0.1000000000 0.2000000000 0.0000000000 + 62 0.8000000000 0.9000000000 0.0000000000 + 63 0.2000000000 0.2000000000 0.0000000000 + 64 0.8000000000 0.8000000000 0.0000000000 + 65 0.6000000000 0.4000000000 0.0000000000 + 66 0.3000000000 0.2000000000 0.0000000000 + 67 0.8000000000 0.7000000000 0.0000000000 + 68 0.5000000000 0.3000000000 0.0000000000 + 69 0.7000000000 0.5000000000 0.0000000000 + 70 0.4000000000 0.2000000000 0.0000000000 + 71 0.8000000000 0.6000000000 0.0000000000 + 72 0.9000000000 1.0000000000 0.0000000000 + 73 0.0000000000 0.1000000000 0.0000000000 + 74 0.9000000000 0.9000000000 0.0000000000 + 75 0.1000000000 0.1000000000 0.0000000000 + 76 0.9000000000 0.8000000000 0.0000000000 + 77 0.6000000000 0.3000000000 0.0000000000 + 78 0.7000000000 0.4000000000 0.0000000000 + 79 0.2000000000 0.1000000000 0.0000000000 + 80 0.5000000000 0.2000000000 0.0000000000 + 81 0.8000000000 0.5000000000 0.0000000000 + 82 0.3000000000 0.1000000000 0.0000000000 + 83 0.9000000000 0.7000000000 0.0000000000 + 84 0.9000000000 0.6000000000 0.0000000000 + 85 0.4000000000 0.1000000000 0.0000000000 + 86 0.7000000000 0.3000000000 0.0000000000 + 87 0.0000000000 0.0000000000 0.0000000000 + 88 1.0000000000 1.0000000000 0.0000000000 + 89 0.6000000000 0.2000000000 0.0000000000 + 90 0.8000000000 0.4000000000 0.0000000000 + 91 0.1000000000 0.0000000000 0.0000000000 + 92 1.0000000000 0.9000000000 0.0000000000 + 93 0.2000000000 0.0000000000 0.0000000000 + 94 1.0000000000 0.8000000000 0.0000000000 + 95 0.9000000000 0.5000000000 0.0000000000 + 96 0.5000000000 0.1000000000 0.0000000000 + 97 0.3000000000 0.0000000000 0.0000000000 + 98 1.0000000000 0.7000000000 0.0000000000 + 99 0.7000000000 0.2000000000 0.0000000000 + 100 0.8000000000 0.3000000000 0.0000000000 + 101 0.4000000000 0.0000000000 0.0000000000 + 102 1.0000000000 0.6000000000 0.0000000000 + 103 0.6000000000 0.1000000000 0.0000000000 + 104 0.9000000000 0.4000000000 0.0000000000 + 105 0.5000000000 0.0000000000 0.0000000000 + 106 1.0000000000 0.5000000000 0.0000000000 + 107 0.8000000000 0.2000000000 0.0000000000 + 108 0.9000000000 0.3000000000 0.0000000000 + 109 0.7000000000 0.1000000000 0.0000000000 + 110 0.6000000000 0.0000000000 0.0000000000 + 111 1.0000000000 0.4000000000 0.0000000000 + 112 0.9000000000 0.2000000000 0.0000000000 + 113 0.8000000000 0.1000000000 0.0000000000 + 114 0.7000000000 0.0000000000 0.0000000000 + 115 1.0000000000 0.3000000000 0.0000000000 + 116 0.9000000000 0.1000000000 0.0000000000 + 117 0.8000000000 0.0000000000 0.0000000000 + 118 1.0000000000 0.2000000000 0.0000000000 + 119 0.9000000000 0.0000000000 0.0000000000 + 120 1.0000000000 0.1000000000 0.0000000000 + 121 1.0000000000 0.0000000000 0.0000000000 +End Nodes + + +Begin Conditions Condition3D // GUI group identifier: Parts Auto1 + 1 1 91 75 87 + 2 1 75 73 87 + 3 1 93 79 91 + 4 1 79 75 91 + 5 1 97 82 93 + 6 1 82 79 93 + 7 1 101 85 97 + 8 1 85 82 97 + 9 1 105 96 101 + 10 1 96 85 101 + 11 1 110 103 105 + 12 1 103 96 105 + 13 1 114 109 110 + 14 1 109 103 110 + 15 1 117 113 114 + 16 1 113 109 114 + 17 1 119 116 117 + 18 1 116 113 117 + 19 1 121 120 119 + 20 1 120 116 119 + 21 1 75 61 73 + 22 1 61 58 73 + 23 1 79 63 75 + 24 1 63 61 75 + 25 1 82 66 79 + 26 1 66 63 79 + 27 1 85 70 82 + 28 1 70 66 82 + 29 1 96 80 85 + 30 1 80 70 85 + 31 1 103 89 96 + 32 1 89 80 96 + 33 1 109 99 103 + 34 1 99 89 103 + 35 1 113 107 109 + 36 1 107 99 109 + 37 1 116 112 113 + 38 1 112 107 113 + 39 1 120 118 116 + 40 1 118 112 116 + 41 1 61 47 58 + 42 1 47 45 58 + 43 1 63 51 61 + 44 1 51 47 61 + 45 1 66 53 63 + 46 1 53 51 63 + 47 1 70 59 66 + 48 1 59 53 66 + 49 1 80 68 70 + 50 1 68 59 70 + 51 1 89 77 80 + 52 1 77 68 80 + 53 1 99 86 89 + 54 1 86 77 89 + 55 1 107 100 99 + 56 1 100 86 99 + 57 1 112 108 107 + 58 1 108 100 107 + 59 1 118 115 112 + 60 1 115 108 112 + 61 1 47 36 45 + 62 1 36 35 45 + 63 1 51 38 47 + 64 1 38 36 47 + 65 1 53 42 51 + 66 1 42 38 51 + 67 1 59 50 53 + 68 1 50 42 53 + 69 1 68 55 59 + 70 1 55 50 59 + 71 1 77 65 68 + 72 1 65 55 68 + 73 1 86 78 77 + 74 1 78 65 77 + 75 1 100 90 86 + 76 1 90 78 86 + 77 1 108 104 100 + 78 1 104 90 100 + 79 1 115 111 108 + 80 1 111 104 108 + 81 1 36 27 35 + 82 1 27 25 35 + 83 1 38 29 36 + 84 1 29 27 36 + 85 1 42 32 38 + 86 1 32 29 38 + 87 1 50 40 42 + 88 1 40 32 42 + 89 1 55 48 50 + 90 1 48 40 50 + 91 1 65 56 55 + 92 1 56 48 55 + 93 1 78 69 65 + 94 1 69 56 65 + 95 1 90 81 78 + 96 1 81 69 78 + 97 1 104 95 90 + 98 1 95 81 90 + 99 1 111 106 104 + 100 1 106 95 104 + 101 1 27 18 25 + 102 1 18 17 25 + 103 1 29 21 27 + 104 1 21 18 27 + 105 1 32 23 29 + 106 1 23 21 29 + 107 1 40 31 32 + 108 1 31 23 32 + 109 1 48 41 40 + 110 1 41 31 40 + 111 1 56 49 48 + 112 1 49 41 48 + 113 1 69 60 56 + 114 1 60 49 56 + 115 1 81 71 69 + 116 1 71 60 69 + 117 1 95 84 81 + 118 1 84 71 81 + 119 1 106 102 95 + 120 1 102 84 95 + 121 1 18 12 17 + 122 1 12 11 17 + 123 1 21 15 18 + 124 1 15 12 18 + 125 1 23 20 21 + 126 1 20 15 21 + 127 1 31 26 23 + 128 1 26 20 23 + 129 1 41 33 31 + 130 1 33 26 31 + 131 1 49 43 41 + 132 1 43 33 41 + 133 1 60 54 49 + 134 1 54 43 49 + 135 1 71 67 60 + 136 1 67 54 60 + 137 1 84 83 71 + 138 1 83 67 71 + 139 1 102 98 84 + 140 1 98 83 84 + 141 1 12 8 11 + 142 1 8 6 11 + 143 1 15 9 12 + 144 1 9 8 12 + 145 1 20 14 15 + 146 1 14 9 15 + 147 1 26 22 20 + 148 1 22 14 20 + 149 1 33 30 26 + 150 1 30 22 26 + 151 1 43 39 33 + 152 1 39 30 33 + 153 1 54 52 43 + 154 1 52 39 43 + 155 1 67 64 54 + 156 1 64 52 54 + 157 1 83 76 67 + 158 1 76 64 67 + 159 1 98 94 83 + 160 1 94 76 83 + 161 1 8 4 6 + 162 1 4 3 6 + 163 1 9 7 8 + 164 1 7 4 8 + 165 1 14 13 9 + 166 1 13 7 9 + 167 1 22 19 14 + 168 1 19 13 14 + 169 1 30 28 22 + 170 1 28 19 22 + 171 1 39 37 30 + 172 1 37 28 30 + 173 1 52 46 39 + 174 1 46 37 39 + 175 1 64 62 52 + 176 1 62 46 52 + 177 1 76 74 64 + 178 1 74 62 64 + 179 1 94 92 76 + 180 1 92 74 76 + 181 1 4 2 3 + 182 1 2 1 3 + 183 1 7 5 4 + 184 1 5 2 4 + 185 1 13 10 7 + 186 1 10 5 7 + 187 1 19 16 13 + 188 1 16 10 13 + 189 1 28 24 19 + 190 1 24 16 19 + 191 1 37 34 28 + 192 1 34 24 28 + 193 1 46 44 37 + 194 1 44 34 37 + 195 1 62 57 46 + 196 1 57 44 46 + 197 1 74 72 62 + 198 1 72 57 62 + 199 1 92 88 74 + 200 1 88 72 74 +End Conditions diff --git a/applications/FSIapplication/tests/test_FSIApplication.py b/applications/FSIapplication/tests/test_FSIApplication.py index 677fd3efe1b6..79f742b36137 100644 --- a/applications/FSIapplication/tests/test_FSIApplication.py +++ b/applications/FSIapplication/tests/test_FSIApplication.py @@ -13,13 +13,14 @@ from SmallTests import NonConformantOneSideMap3D_test1 as TNonConformantOneSideMap3D_test1 from SmallTests import NonConformantOneSideMapTwoFaces3D_test1 as TNonConformantOneSideMapTwoFaces3D_test1 from KratosExecuteConvergenceAcceleratorTest import KratosExecuteConvergenceAcceleratorTest as TConvergenceAcceleratorTest +from variable_redistribution_test import VariableRedistributionTest ## NIGTHLY TESTS ## VALIDATION TESTS from ValidationTests import MokBenchmarkTest as TMokBenchmark -def AssambleTestSuites(): +def AssembleTestSuites(): ''' Populates the test suites to run. Populates the test suites to run. At least, it should populate the suites: @@ -44,6 +45,11 @@ def AssambleTestSuites(): smallSuite.addTest(TConvergenceAcceleratorTest('test_mvqn_recusive_accelerator')) smallSuite.addTest(TConvergenceAcceleratorTest('test_accelerator_with_jacobian')) smallSuite.addTest(TFSIProblemEmulatorTest('test_execution')) + smallSuite.addTest(VariableRedistributionTest('testLinearFunction')) + smallSuite.addTest(VariableRedistributionTest('testSharpCorners')) + smallSuite.addTest(VariableRedistributionTest('testVector')) + smallSuite.addTest(VariableRedistributionTest('testQuadratic')) + smallSuite.addTest(VariableRedistributionTest('testNodalArea')) # Create a test suit with the selected tests plus all small tests nightSuite = suites['nightly'] @@ -60,4 +66,4 @@ def AssambleTestSuites(): return suites if __name__ == '__main__': - KratosUnittest.runTests(AssambleTestSuites()) + KratosUnittest.runTests(AssembleTestSuites()) diff --git a/applications/FSIapplication/tests/variable_redistribution_test.py b/applications/FSIapplication/tests/variable_redistribution_test.py new file mode 100644 index 000000000000..f88788042031 --- /dev/null +++ b/applications/FSIapplication/tests/variable_redistribution_test.py @@ -0,0 +1,258 @@ +from KratosMultiphysics import * +from KratosMultiphysics.FSIApplication import * + +import KratosMultiphysics.KratosUnittest as UnitTest + +from os import remove + +class WorkFolderScope: + def __init__(self, work_folder): + self.currentPath = os.getcwd() + self.scope = os.path.abspath(os.path.join(os.path.dirname(os.path.realpath(__file__)),work_folder)) + + def __enter__(self): + os.chdir(self.scope) + + def __exit__(self, type, value, traceback): + os.chdir(self.currentPath) + +class VariableRedistributionTest(UnitTest.TestCase): + + def setUp(self): + self.domain_size = 2 + self.input_file = "redistribution_test" + self.work_folder = "RedistributionTest" + + self.redistribution_iterations = 100 + self.redistribution_tolerance = 1e-7 + + self.check_tolerance = 1e-6 + self.print_output = False + + self.mapped_function = None + + def tearDown(self): + self.deleteOutFile(self.input_file+'.time') + + def deleteOutFile(self,filename): + with WorkFolderScope(self.work_folder): + try: + remove(filename) + except FileNotFoundError as e: + pass + + def testLinearFunction(self): + def Flag1Check(node): + return node.GetSolutionStepValue(FLAG_VARIABLE) == 1.0 + + def ReferenceSolution(node,variable): + node.SetSolutionStepValue(variable,node.X) + + self.RunTestCase( + Flag1Check, + ReferenceSolution, + PRESSURE, + NODAL_PAUX, + TEMPERATURE + ) + + def testSharpCorners(self): + + def FlagDefinedCheck(node): + return node.GetSolutionStepValue(FLAG_VARIABLE) > 0.0 + + def ReferenceSolution(node,variable): + node.SetSolutionStepValue(variable, 10.*node.X + node.Y) + + + self.RunTestCase( + FlagDefinedCheck, + ReferenceSolution, + PRESSURE, + NODAL_PAUX, + TEMPERATURE + ) + + def testQuadratic(self): + + def FlagDefinedCheck(node): + return node.GetSolutionStepValue(FLAG_VARIABLE) > 0.0 + + def ReferenceSolution(node,variable): + node.SetSolutionStepValue(variable, node.X*node.X + node.Y*node.Z) + + + self.RunTestCase( + FlagDefinedCheck, + ReferenceSolution, + PRESSURE, + NODAL_PAUX, + TEMPERATURE + ) + + def testVector(self): + + def FlagDefinedCheck(node): + return node.GetSolutionStepValue(FLAG_VARIABLE) > 0.0 + + def ReferenceSolution(node,variable): + value = Array3() + value[0] = node.Y + value[1] = 10.*node.X + node.Z + value[2] = 500 + node.SetSolutionStepValue(variable, value) + + + self.RunTestCase( + FlagDefinedCheck, + ReferenceSolution, + VELOCITY, + VORTICITY, + ACCELERATION + ) + + + def RunTestCase(self,inteface_check,set_reference,reference_variable,intermediate_variable,result_variable): + with WorkFolderScope(self.work_folder): + + self.SetUpProblem() + + for node in self.model_part.Nodes: + if inteface_check(node): + node.Set(INTERFACE,True) + set_reference(node,reference_variable) + + self.GenerateInterface() + + VariableRedistributionUtility.ConvertDistributedValuesToPoint( + self.interface_model_part, + reference_variable, + intermediate_variable) + + VariableRedistributionUtility.DistributePointValues( + self.interface_model_part, + intermediate_variable, + result_variable, + self.redistribution_tolerance, + self.redistribution_iterations) + + if self.print_output: + self.InitializeOutput() + self.PrintOutput() + self.FinalizeOutput() + + if KratosGlobals.Kernel.HasDoubleVariable(reference_variable.Name()): + self.CheckDoubleResults(reference_variable,result_variable) + elif KratosGlobals.Kernel.HasArrayVariable(reference_variable.Name()): + self.CheckArrayResults(reference_variable,result_variable) + else: + self.fail("Failing due to incorrect test definition: Wrong variable type") + + def testNodalArea(self): + self.input_file = "square10" + + with WorkFolderScope(self.work_folder): + + self.SetUpProblem() + + for node in self.model_part.Nodes: + node.Set(INTERFACE,True) + node.SetSolutionStepValue(PRESSURE,1.0) + + self.GenerateInterface() + + VariableRedistributionUtility.ConvertDistributedValuesToPoint( + self.interface_model_part, + PRESSURE, + TEMPERATURE) + + for cond in self.model_part.Conditions: + area = cond.GetArea() + for node in cond.GetNodes(): + nodal_area = node.GetSolutionStepValue(NODAL_PAUX) + node.SetSolutionStepValue(NODAL_PAUX,nodal_area+area/3.0) + + if self.print_output: + self.InitializeOutput() + self.PrintOutput() + self.FinalizeOutput() + + self.CheckDoubleResults(TEMPERATURE,NODAL_PAUX) + + def SetUpProblem(self): + + self.model_part = ModelPart("Model") + self.model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) + self.model_part.AddNodalSolutionStepVariable(PRESSURE) + self.model_part.AddNodalSolutionStepVariable(NODAL_PAUX) + self.model_part.AddNodalSolutionStepVariable(TEMPERATURE) + self.model_part.AddNodalSolutionStepVariable(MAPPER_SCALAR_PROJECTION_RHS) + self.model_part.AddNodalSolutionStepVariable(VELOCITY) + self.model_part.AddNodalSolutionStepVariable(VORTICITY) + self.model_part.AddNodalSolutionStepVariable(ACCELERATION) + self.model_part.AddNodalSolutionStepVariable(MAPPER_VECTOR_PROJECTION_RHS) + + model_part_io = ModelPartIO(self.input_file) + model_part_io.ReadModelPart(self.model_part) + + self.model_part.SetBufferSize(1) + + def GenerateInterface(self): + self.interface_model_part = ModelPart("Interface") + interface_model_part_generator = InterfacePreprocess() + interface_model_part_generator.GenerateTriangleInterfacePart(self.model_part,self.interface_model_part) + + + def CheckDoubleResults(self,reference_variable,result_variable): + + for node in self.interface_model_part.Nodes: + reference = node.GetSolutionStepValue(reference_variable) + result = node.GetSolutionStepValue(result_variable) + self.assertAlmostEqual(reference, result, delta=self.check_tolerance) + + def CheckArrayResults(self,reference_variable,result_variable): + for node in self.interface_model_part.Nodes: + reference = node.GetSolutionStepValue(reference_variable) + result = node.GetSolutionStepValue(result_variable) + self.assertAlmostEqual(reference[0], result[0], delta=self.check_tolerance) + self.assertAlmostEqual(reference[1], result[1], delta=self.check_tolerance) + self.assertAlmostEqual(reference[2], result[2], delta=self.check_tolerance) + + def InitializeOutput(self): + gid_mode = GiDPostMode.GiD_PostBinary + multifile = MultiFileFlag.SingleFile + deformed_mesh_flag = WriteDeformedMeshFlag.WriteUndeformed + write_conditions = WriteConditionsFlag.WriteConditions + self.gid_io = GidIO(self.input_file,gid_mode,multifile,deformed_mesh_flag, write_conditions) + + mesh_name = 0.0 + self.gid_io.InitializeMesh( mesh_name) + self.gid_io.WriteMesh( self.model_part.GetMesh() ) + self.gid_io.FinalizeMesh() + self.gid_io.InitializeResults(mesh_name,(self.model_part).GetMesh()) + + def FinalizeOutput(self): + self.gid_io.FinalizeResults() + + def PrintOutput(self): + label = self.model_part.ProcessInfo[TIME] + self.gid_io.WriteNodalResults(PRESSURE,self.model_part.Nodes,label,0) + self.gid_io.WriteNodalResults(NODAL_PAUX,self.model_part.Nodes,label,0) + self.gid_io.WriteNodalResults(TEMPERATURE,self.model_part.Nodes,label,0) + self.gid_io.WriteNodalResults(MAPPER_SCALAR_PROJECTION_RHS,self.model_part.Nodes,label,0) + self.gid_io.WriteNodalResults(VELOCITY,self.model_part.Nodes,label,0) + self.gid_io.WriteNodalResults(VORTICITY,self.model_part.Nodes,label,0) + self.gid_io.WriteNodalResults(ACCELERATION,self.model_part.Nodes,label,0) + self.gid_io.WriteNodalResults(MAPPER_VECTOR_PROJECTION_RHS,self.model_part.Nodes,label,0) + + +if __name__ == '__main__': + test = VariableRedistributionTest() + test.setUp() + test.print_output = True + #test.testLinearFunction() + #test.testSharpCorners() + #test.testVector() + #test.testQuadratic() + test.testNodalArea() + test.tearDown() \ No newline at end of file diff --git a/applications/FluidDynamicsApplication/CMakeLists.txt b/applications/FluidDynamicsApplication/CMakeLists.txt index 6c45035829a6..b1deec05aba2 100644 --- a/applications/FluidDynamicsApplication/CMakeLists.txt +++ b/applications/FluidDynamicsApplication/CMakeLists.txt @@ -68,7 +68,7 @@ install(TARGETS KratosFluidDynamicsApplication DESTINATION libs ) if(${INSTALL_TESTING_FILES} MATCHES ON) get_filename_component (CURRENT_DIR_NAME ${CMAKE_CURRENT_SOURCE_DIR} NAME) - install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/tests DESTINATION applications/${CURRENT_DIR_NAME} FILES_MATCHING PATTERN "*.py" PATTERN ".svn" EXCLUDE) + install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/tests DESTINATION applications/${CURRENT_DIR_NAME} FILES_MATCHING PATTERN "*.py" PATTERN "*.json" PATTERN "*.mdpa" PATTERN ".svn" EXCLUDE) endif(${INSTALL_TESTING_FILES} MATCHES ON) if(${INSTALL_PYTHON_FILES} MATCHES ON) diff --git a/applications/FluidDynamicsApplication/custom_conditions/navier_stokes_wall_condition.h b/applications/FluidDynamicsApplication/custom_conditions/navier_stokes_wall_condition.h index 47e2b1bcdbe1..fbbfd8cca4c3 100644 --- a/applications/FluidDynamicsApplication/custom_conditions/navier_stokes_wall_condition.h +++ b/applications/FluidDynamicsApplication/custom_conditions/navier_stokes_wall_condition.h @@ -248,7 +248,8 @@ class KRATOS_API(FLUID_DYNAMICS_APPLICATION) NavierStokesWallCondition : public // Store the outlet inflow prevention constants in the data structure data.delta = 1e-2; // TODO: Decide if this constant should be fixed or not - data.charVel = rCurrentProcessInfo[CHARACTERISTIC_VELOCITY]; + const ProcessInfo& rProcessInfo = rCurrentProcessInfo; // const to avoid race conditions on data_value_container access/initialization + data.charVel = rProcessInfo[CHARACTERISTIC_VELOCITY]; // Gauss point information GeometryType& rGeom = this->GetGeometry(); @@ -329,7 +330,8 @@ class KRATOS_API(FLUID_DYNAMICS_APPLICATION) NavierStokesWallCondition : public // Store the outlet inflow prevention constants in the data structure data.delta = 1e-2; // TODO: Decide if this constant should be fixed or not - data.charVel = rCurrentProcessInfo[CHARACTERISTIC_VELOCITY]; + const ProcessInfo& rProcessInfo = rCurrentProcessInfo; // const to avoid race conditions on data_value_container access/initialization + data.charVel = rProcessInfo[CHARACTERISTIC_VELOCITY]; // Gauss point information GeometryType& rGeom = this->GetGeometry(); diff --git a/applications/FluidDynamicsApplication/custom_constitutive/bingham_3d_law.cpp b/applications/FluidDynamicsApplication/custom_constitutive/bingham_3d_law.cpp index ae70faf0c07f..cf5591b1bacf 100644 --- a/applications/FluidDynamicsApplication/custom_constitutive/bingham_3d_law.cpp +++ b/applications/FluidDynamicsApplication/custom_constitutive/bingham_3d_law.cpp @@ -109,9 +109,9 @@ void Bingham3DLaw::CalculateMaterialResponseCauchy (Parameters& rValues) // if(gamma_dot < min_gamma_dot) // { noalias(C) = ZeroMatrix(6,6); - C(0,0) = 4.0/3.0*mu_effective; C(0,1) = -2.0/3.0*mu_effective; C(0,2) = -2.0/3.0*mu_effective; - C(1,2) = -2.0/3.0*mu_effective; C(1,1) = 4.0/3.0*mu_effective; C(1,2) = -2.0/3.0*mu_effective; - C(2,2) = -2.0/3.0*mu_effective; C(2,2) = -2.0/3.0*mu_effective; C(2,2) = 4.0/3.0*mu_effective; + C(0, 0) = 4.0 / 3.0*mu_effective; C(0, 1) = -2.0 / 3.0*mu_effective; C(0, 2) = -2.0 / 3.0*mu_effective; + C(1, 0) = -2.0 / 3.0*mu_effective; C(1, 1) = 4.0 / 3.0*mu_effective; C(1, 2) = -2.0 / 3.0*mu_effective; + C(2, 0) = -2.0 / 3.0*mu_effective; C(2, 1) = -2.0 / 3.0*mu_effective; C(2, 2) = 4.0 / 3.0*mu_effective; C(3,3) = mu_effective; C(4,4) = mu_effective; C(5,5) = mu_effective; diff --git a/applications/FluidDynamicsApplication/custom_constitutive/herschel_bulkey_3d_law.cpp b/applications/FluidDynamicsApplication/custom_constitutive/herschel_bulkey_3d_law.cpp index 03ff38db2c7c..70fa7b83e72a 100644 --- a/applications/FluidDynamicsApplication/custom_constitutive/herschel_bulkey_3d_law.cpp +++ b/applications/FluidDynamicsApplication/custom_constitutive/herschel_bulkey_3d_law.cpp @@ -106,9 +106,9 @@ void HerschelBulkey3DLaw::CalculateMaterialResponseCauchy (Parameters& rValues) // if(gamma_dot < min_gamma_dot) // { noalias(C) = ZeroMatrix(6,6); - C(0,0) = 4.0/3.0*mu_effective; C(0,1) = -2.0/3.0*mu_effective; C(0,2) = -2.0/3.0*mu_effective; - C(1,2) = -2.0/3.0*mu_effective; C(1,1) = 4.0/3.0*mu_effective; C(1,2) = -2.0/3.0*mu_effective; - C(2,2) = -2.0/3.0*mu_effective; C(2,2) = -2.0/3.0*mu_effective; C(2,2) = 4.0/3.0*mu_effective; + C(0, 0) = 4.0 / 3.0*mu_effective; C(0, 1) = -2.0 / 3.0*mu_effective; C(0, 2) = -2.0 / 3.0*mu_effective; + C(1, 0) = -2.0 / 3.0*mu_effective; C(1, 1) = 4.0 / 3.0*mu_effective; C(1, 2) = -2.0 / 3.0*mu_effective; + C(2, 0) = -2.0 / 3.0*mu_effective; C(2, 1) = -2.0 / 3.0*mu_effective; C(2, 2) = 4.0 / 3.0*mu_effective; C(3,3) = mu_effective; C(4,4) = mu_effective; C(5,5) = mu_effective; diff --git a/applications/FluidDynamicsApplication/custom_constitutive/newtonian_3d_law.cpp b/applications/FluidDynamicsApplication/custom_constitutive/newtonian_3d_law.cpp index 69373ee705ce..a82b42e9e6ec 100644 --- a/applications/FluidDynamicsApplication/custom_constitutive/newtonian_3d_law.cpp +++ b/applications/FluidDynamicsApplication/custom_constitutive/newtonian_3d_law.cpp @@ -93,8 +93,8 @@ void Newtonian3DLaw::CalculateMaterialResponseCauchy (Parameters& rValues) noalias(C) = ZeroMatrix(6,6); C(0,0) = 4.0/3.0*mu; C(0,1) = -2.0/3.0*mu; C(0,2) = -2.0/3.0*mu; - C(1,2) = -2.0/3.0*mu; C(1,1) = 4.0/3.0*mu; C(1,2) = -2.0/3.0*mu; - C(2,2) = -2.0/3.0*mu; C(2,2) = -2.0/3.0*mu; C(2,2) = 4.0/3.0*mu; + C(1,0) = -2.0/3.0*mu; C(1,1) = 4.0/3.0*mu; C(1,2) = -2.0/3.0*mu; + C(2,0) = -2.0/3.0*mu; C(2,1) = -2.0/3.0*mu; C(2,2) = 4.0/3.0*mu; C(3,3) = mu; C(4,4) = mu; C(5,5) = mu; diff --git a/applications/FluidDynamicsApplication/custom_elements/embedded_navier_stokes.h b/applications/FluidDynamicsApplication/custom_elements/embedded_navier_stokes.h index 1986362078be..20d8a14ff902 100644 --- a/applications/FluidDynamicsApplication/custom_elements/embedded_navier_stokes.h +++ b/applications/FluidDynamicsApplication/custom_elements/embedded_navier_stokes.h @@ -1354,8 +1354,8 @@ class EmbeddedNavierStokes : public NavierStokes const bounded_matrix aux_matrix_BtransAtrans = prod(trans(B_matrix_exp), trans(voigt_normal_projection_matrix)); const bounded_matrix aux_matrix_BtransAtransPtan = prod(aux_matrix_BtransAtrans, tangential_projection_matrix); const bounded_matrix aux_matrix_CB = prod(rData.C, B_matrix_exp); - const bounded_matrix aux_matrix_ACB = prod(voigt_normal_projection_matrix, aux_matrix_CB); - const bounded_matrix aux_matrix_BtransAtransPtanACB = prod(aux_matrix_BtransAtransPtan, aux_matrix_ACB); + const bounded_matrix aux_matrix_ACB = prod(voigt_normal_projection_matrix, aux_matrix_CB); + const bounded_matrix aux_matrix_BtransAtransPtanACB = prod(aux_matrix_BtransAtransPtan, aux_matrix_ACB); for (unsigned int icut=0; icut } // Contribution coming from the traction vector tangencial component - auxLeftHandSideMatrix_1 += adjoint_consistency_term*coeff_1*weight*aux_matrix_BtransAtransPtanACB; + noalias(auxLeftHandSideMatrix_1) += adjoint_consistency_term*coeff_1*weight*aux_matrix_BtransAtransPtanACB; // Contribution coming from the shear force generated by the velocity jump - auxLeftHandSideMatrix_2 += adjoint_consistency_term*coeff_2*weight*prod(aux_matrix_BtransAtransPtan, N_aux); + noalias(auxLeftHandSideMatrix_2) += adjoint_consistency_term*coeff_2*weight*prod(aux_matrix_BtransAtransPtan, N_aux); } // LHS outside Nitche contribution assembly - rLeftHandSideMatrix -= auxLeftHandSideMatrix_1; - rLeftHandSideMatrix -= auxLeftHandSideMatrix_2; + noalias(rLeftHandSideMatrix) -= auxLeftHandSideMatrix_1; + noalias(rLeftHandSideMatrix) -= auxLeftHandSideMatrix_2; // RHS outside Nitche contribution assembly // If level set velocity is not 0, add its contribution to the RHS @@ -1399,13 +1399,13 @@ class EmbeddedNavierStokes : public NavierStokes } } - auxRightHandSideVector += prod(auxLeftHandSideMatrix_2, embedded_vel_exp); + noalias(auxRightHandSideVector) += prod(auxLeftHandSideMatrix_2, embedded_vel_exp); } // Note that since we work with a residualbased formulation, the RHS is f_gamma - LHS*prev_sol - rRightHandSideVector -= auxRightHandSideVector; - rRightHandSideVector += prod(auxLeftHandSideMatrix_1, prev_sol); - rRightHandSideVector += prod(auxLeftHandSideMatrix_2, prev_sol); + noalias(rRightHandSideVector) -= auxRightHandSideVector; + noalias(rRightHandSideVector) += prod(auxLeftHandSideMatrix_1, prev_sol); + noalias(rRightHandSideVector) += prod(auxLeftHandSideMatrix_2, prev_sol); } diff --git a/applications/FluidDynamicsApplication/custom_elements/fractional_step.cpp b/applications/FluidDynamicsApplication/custom_elements/fractional_step.cpp index b66a97cd0b92..a617646261f8 100644 --- a/applications/FluidDynamicsApplication/custom_elements/fractional_step.cpp +++ b/applications/FluidDynamicsApplication/custom_elements/fractional_step.cpp @@ -904,7 +904,7 @@ int FractionalStep::Check(const ProcessInfo &rCurrentProcessInfo) if(this->GetGeometry()[i].HasDofFor(PRESSURE) == false) KRATOS_THROW_ERROR(std::invalid_argument,"missing PRESSURE component degree of freedom on node ",this->GetGeometry()[i].Id()); } - + // If this is a 2D problem, check that nodes are in XY plane if (this->GetGeometry().WorkingSpaceDimension() == 2) { @@ -1113,7 +1113,7 @@ void FractionalStep::CalculateGeometryData(ShapeFunctionDerivativesArrayTy for (unsigned int g = 0; g < rGeom.IntegrationPointsNumber(GeometryData::GI_GAUSS_2); g++) rGaussWeights[g] = DetJ[g] * IntegrationPoints[g].Weight(); - + /* const GeometryType& rGeom = this->GetGeometry(); const SizeType NumNodes = rGeom.PointsNumber(); @@ -1195,15 +1195,15 @@ double FractionalStep::EffectiveViscosity(double Density, double ElemSize, const ProcessInfo &rProcessInfo) { - double Csmag = this->GetValue(C_SMAGORINSKY); + const FractionalStep* const_this = static_cast*> (this); + const double Csmag = const_this->GetValue(C_SMAGORINSKY); double Viscosity = 0.0; this->EvaluateInPoint(Viscosity,VISCOSITY,rN); if (Csmag > 0.0) { - double StrainRate = this->EquivalentStrainRate(rDN_DX); // (2SijSij)^0.5 - double LengthScale = Csmag*ElemSize; - LengthScale *= LengthScale; // square + const double StrainRate = this->EquivalentStrainRate(rDN_DX); // (2SijSij)^0.5 + const double LengthScale = std::pow(Csmag*ElemSize, 2); Viscosity += 2.0*LengthScale*StrainRate; } @@ -1450,7 +1450,7 @@ void FractionalStep::CalculateProjectionRHS(VectorType& rMomentumRHS, const array_1d& vel = this->GetGeometry()[i].FastGetSolutionStepValue(VELOCITY); for (SizeType d = 0; d < TDim; ++d) Convection[d] += ConvOp[i] * vel[d]; - + } array_1d PressureGradient(TDim,0.0); @@ -1494,10 +1494,10 @@ void FractionalStep::CalculateProjectionRHS(VectorType& rConvTerm, array_1d Convection(3,0.0); for (unsigned int i = 0; i < NumNodes; ++i) - { + { const array_1d& vel = this->GetGeometry()[i].FastGetSolutionStepValue(VELOCITY); for (unsigned int d = 0; d < TDim; ++d) - Convection[d] += ConvOp[i] * vel[d]; + Convection[d] += ConvOp[i] * vel[d]; } array_1d PressureGradient(TDim,0.0); @@ -1585,7 +1585,7 @@ void FractionalStep::ModulatedGradientDiffusion(MatrixType& rDampMatrix, // C_epsilon const double Ce = 1.0; - + // ksgs double ksgs = -4*AvgDeltaSq*GijSij/(Ce*Ce*Gkk); diff --git a/applications/FluidDynamicsApplication/custom_strategies/strategies/fs_strategy.h b/applications/FluidDynamicsApplication/custom_strategies/strategies/fs_strategy.h index 2b4d92e6a05c..b3efed9e4e0d 100644 --- a/applications/FluidDynamicsApplication/custom_strategies/strategies/fs_strategy.h +++ b/applications/FluidDynamicsApplication/custom_strategies/strategies/fs_strategy.h @@ -824,31 +824,30 @@ class FSStrategy : public SolvingStrategy& r_const_node = *itNode; + + if ( r_const_node.GetValue(rSlipWallFlag) != 0.0 ) { - if ( itNode->GetValue(rSlipWallFlag) != 0.0 ) - { - const array_1d& rNormal = itNode->FastGetSolutionStepValue(NORMAL); - array_1d& rDeltaVelocity = itNode->FastGetSolutionStepValue(FRACT_VEL); + const array_1d& rNormal = itNode->FastGetSolutionStepValue(NORMAL); + array_1d& rDeltaVelocity = itNode->FastGetSolutionStepValue(FRACT_VEL); - double Proj = rNormal[0] * rDeltaVelocity[0]; - double Norm = rNormal[0] * rNormal[0]; + double Proj = rNormal[0] * rDeltaVelocity[0]; + double Norm = rNormal[0] * rNormal[0]; - for (unsigned int d = 1; d < mDomainSize; ++d) - { - Proj += rNormal[d] * rDeltaVelocity[d]; - Norm += rNormal[d] * rNormal[d]; - } - - Proj /= Norm; - rDeltaVelocity -= Proj * rNormal; + for (unsigned int d = 1; d < mDomainSize; ++d) + { + Proj += rNormal[d] * rDeltaVelocity[d]; + Norm += rNormal[d] * rNormal[d]; } + + Proj /= Norm; + rDeltaVelocity -= Proj * rNormal; } } } diff --git a/applications/FluidDynamicsApplication/python_scripts/apply_inlet_process.py b/applications/FluidDynamicsApplication/python_scripts/apply_inlet_process.py index 2d377fbf70a0..4fe1fdde2b1a 100644 --- a/applications/FluidDynamicsApplication/python_scripts/apply_inlet_process.py +++ b/applications/FluidDynamicsApplication/python_scripts/apply_inlet_process.py @@ -18,16 +18,20 @@ def __init__(self, Model, settings): "variable_name" : "VELOCITY", "modulus" : 0.0, "constrained" : true, - "direction" : "automatic_inwards_normal", + "direction" : [1.0,0.0,0.0], "interval" : [0.0,"End"] } """) # Trick: allow "modulus" and "direction" to be a double or a string value (otherwise the ValidateAndAssignDefaults might fail) - if(settings.Has("modulus")): - if(settings["modulus"].IsString()): + if (settings.Has("modulus")): + if (settings["modulus"].IsString()): default_settings["modulus"].SetString("0.0") + if (settings.Has("direction")): + if (settings["direction"].IsString()): + default_settings["direction"].SetString("automatic_inwards_normal") + settings.ValidateAndAssignDefaults(default_settings) # Check input data diff --git a/applications/FluidDynamicsApplication/python_scripts/apply_outlet_process.py b/applications/FluidDynamicsApplication/python_scripts/apply_outlet_process.py index 6c7aa3ec1e51..dbec2aa2c8c6 100644 --- a/applications/FluidDynamicsApplication/python_scripts/apply_outlet_process.py +++ b/applications/FluidDynamicsApplication/python_scripts/apply_outlet_process.py @@ -96,6 +96,12 @@ def ExecuteFinalizeSolutionStep(self): # Private methods section def _AddOutletHydrostaticComponent(self): + # Initialize body force value (avoid segfault in MPI if the local mesh has no outlet nodes) + body_force = KratosMultiphysics.Vector(3) + body_force[0] = 0.0 + body_force[1] = 0.0 + body_force[2] = 0.0 + # Get the body force value for node in self.outlet_model_part.Nodes: body_force = node.GetSolutionStepValue(KratosMultiphysics.BODY_FORCE, 0) diff --git a/applications/FluidDynamicsApplication/python_scripts/navier_stokes_base_solver.py b/applications/FluidDynamicsApplication/python_scripts/navier_stokes_base_solver.py index 17032be1841e..fe388ccf3c6e 100644 --- a/applications/FluidDynamicsApplication/python_scripts/navier_stokes_base_solver.py +++ b/applications/FluidDynamicsApplication/python_scripts/navier_stokes_base_solver.py @@ -106,6 +106,7 @@ def AddVariables(self): self.main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.ADVPROJ) self.main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.DIVPROJ) self.main_model_part.AddNodalSolutionStepVariable(KratosCFD.PATCH_INDEX) # PATCH_INDEX belongs to FluidDynamicsApp. + self.main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.EXTERNAL_PRESSURE) print("Base class fluid solver variables added correctly") diff --git a/applications/FluidDynamicsApplication/python_scripts/trilinos_navier_stokes_embedded_solver.py b/applications/FluidDynamicsApplication/python_scripts/trilinos_navier_stokes_embedded_solver.py index f32a9a2044b6..54ebb968e19f 100644 --- a/applications/FluidDynamicsApplication/python_scripts/trilinos_navier_stokes_embedded_solver.py +++ b/applications/FluidDynamicsApplication/python_scripts/trilinos_navier_stokes_embedded_solver.py @@ -151,8 +151,7 @@ def Initialize(self): self.conv_criteria = KratosTrilinos.TrilinosUPCriteria(self.settings["relative_velocity_tolerance"].GetDouble(), self.settings["absolute_velocity_tolerance"].GetDouble(), self.settings["relative_pressure_tolerance"].GetDouble(), - self.settings["absolute_pressure_tolerance"].GetDouble(), - self.EpetraCommunicator) + self.settings["absolute_pressure_tolerance"].GetDouble()) ## Constructing the BDF process (time coefficients update) self.bdf_process = KratosMultiphysics.ComputeBDFCoefficientsProcess(self.computing_model_part,self.settings["time_order"].GetInt()) diff --git a/applications/FluidDynamicsApplication/python_scripts/trilinos_navier_stokes_solver_vmsmonolithic.py b/applications/FluidDynamicsApplication/python_scripts/trilinos_navier_stokes_solver_vmsmonolithic.py index 7e638579f621..9414256f95f5 100644 --- a/applications/FluidDynamicsApplication/python_scripts/trilinos_navier_stokes_solver_vmsmonolithic.py +++ b/applications/FluidDynamicsApplication/python_scripts/trilinos_navier_stokes_solver_vmsmonolithic.py @@ -155,8 +155,7 @@ def Initialize(self): self.conv_criteria = KratosTrilinos.TrilinosUPCriteria(self.settings["relative_velocity_tolerance"].GetDouble(), self.settings["absolute_velocity_tolerance"].GetDouble(), self.settings["relative_pressure_tolerance"].GetDouble(), - self.settings["absolute_pressure_tolerance"].GetDouble(), - self.EpetraCommunicator) + self.settings["absolute_pressure_tolerance"].GetDouble()) ## Creating the Trilinos time scheme if (self.settings["turbulence_model"].GetString() == "None"): diff --git a/applications/FluidDynamicsApplication/tests/volume_source_test.py b/applications/FluidDynamicsApplication/tests/volume_source_test.py index efef501cd49b..495ff7dde6a2 100644 --- a/applications/FluidDynamicsApplication/tests/volume_source_test.py +++ b/applications/FluidDynamicsApplication/tests/volume_source_test.py @@ -254,7 +254,6 @@ def checkResults(self): with open(self.reference_file+'.csv','r') as reference_file: reference_file.readline() # skip header line = reference_file.readline() - node_iter = self.model_part.Nodes for node in self.model_part.Nodes: values = [ float(i) for i in line.rstrip('\n ').split(',') ] diff --git a/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_membrane_element.cpp b/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_membrane_element.cpp index 3ef70f29fc07..2da70ddd0098 100644 --- a/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_membrane_element.cpp +++ b/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_membrane_element.cpp @@ -309,7 +309,7 @@ void MeshlessMembraneElement::CalculateOnIntegrationPoints( // CalculateStrain(StrainVector, C); // ConstitutiveLaw::Parameters Values(GetGeometry(), GetProperties(), rCurrentProcessInfo); - // Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + // Values.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); // Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRESS); // Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, false); @@ -485,7 +485,7 @@ void MeshlessMembraneElement::FinalizeSolutionStep( { // // ConstitutiveLaw::Parameters Values (GetGeometry(),GetProperties(),rCurrentProcessInfo); - // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRAIN, false); + // Values.GetOptions().Set (ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRESS); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); // Matrix dummy = ZeroMatrix ( 0, 0 ); @@ -1065,7 +1065,7 @@ void MeshlessMembraneElement::CalculateAll( ConstitutiveLaw::Parameters Values(GetGeometry(), GetProperties(), rCurrentProcessInfo); - Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + Values.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRESS); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); diff --git a/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_shell_element.cpp b/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_shell_element.cpp index 9e977ae8daf0..0af0e9e0c308 100644 --- a/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_shell_element.cpp +++ b/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_shell_element.cpp @@ -335,7 +335,7 @@ void MeshlessShellElement::CalculateOnIntegrationPoints( // CalculateStrain(StrainVector, C); // ConstitutiveLaw::Parameters Values(GetGeometry(), GetProperties(), rCurrentProcessInfo); - // Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + // Values.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); // Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRESS); // Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, false); @@ -433,7 +433,7 @@ void MeshlessShellElement::FinalizeSolutionStep( { // // ConstitutiveLaw::Parameters Values (GetGeometry(),GetProperties(),rCurrentProcessInfo); - // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRAIN, false); + // Values.GetOptions().Set (ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRESS); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); // Matrix dummy = ZeroMatrix ( 0, 0 ); @@ -1042,7 +1042,7 @@ void MeshlessShellElement::CalculateAll( //set up Constitutive Law ConstitutiveLaw::Parameters Values(GetGeometry(), GetProperties(), rCurrentProcessInfo); - Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + Values.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRESS); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); diff --git a/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_shell_element_old.cpp b/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_shell_element_old.cpp index 3685f0877a59..e3206338e856 100644 --- a/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_shell_element_old.cpp +++ b/applications/IGAStructuralMechanicsApplication/custom_elements/meshless_shell_element_old.cpp @@ -368,7 +368,7 @@ void MeshlessShellElement::CalculateOnIntegrationPoints( // CalculateStrain(StrainVector, C); // ConstitutiveLaw::Parameters Values(GetGeometry(), GetProperties(), rCurrentProcessInfo); - // Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + // Values.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); // Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRESS); // Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, false); @@ -544,7 +544,7 @@ void MeshlessShellElement::FinalizeSolutionStep( { // // ConstitutiveLaw::Parameters Values (GetGeometry(),GetProperties(),rCurrentProcessInfo); - // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRAIN, false); + // Values.GetOptions().Set (ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRESS); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); // Matrix dummy = ZeroMatrix ( 0, 0 ); @@ -1278,7 +1278,7 @@ void MeshlessShellElement::CalculateAll( ConstitutiveLaw::Parameters Values(GetGeometry(), GetProperties(), rCurrentProcessInfo); - Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + Values.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRESS); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); diff --git a/applications/LagrangianMPMApplication/custom_elements/updated_lagrangian_mpm_element.cpp b/applications/LagrangianMPMApplication/custom_elements/updated_lagrangian_mpm_element.cpp index 9294bb3b4d51..973b888eaec0 100644 --- a/applications/LagrangianMPMApplication/custom_elements/updated_lagrangian_mpm_element.cpp +++ b/applications/LagrangianMPMApplication/custom_elements/updated_lagrangian_mpm_element.cpp @@ -142,7 +142,7 @@ void UpdatedLagrangianMPMElement::FinalizeSolutionStep( ProcessInfo& rCurrentPro //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); //compute element kinematics B, F, DN_DX ... @@ -342,7 +342,7 @@ void UpdatedLagrangianMPMElement::CalculateElementalSystem( MatrixType& rLeftHan Flags &ConstitutiveLawOptions=Values.GetOptions(); //std::cout<<"in CalculateElementalSystem 5"< mapper_factory = class_("MapperFactory", init()) + class_< MapperFactory > mapper_factory = class_("MapperFactory", init()) .def("UpdateInterface", pUpdateInterface) .def("UpdateInterface", pUpdateInterfaceOptions) .def("UpdateInterface", pUpdateInterfaceSearchRadius) diff --git a/applications/MappingApplication/custom_utilities/interface_geometry_object.h b/applications/MappingApplication/custom_utilities/interface_geometry_object.h index f0e75dce954a..e3a756313a43 100644 --- a/applications/MappingApplication/custom_utilities/interface_geometry_object.h +++ b/applications/MappingApplication/custom_utilities/interface_geometry_object.h @@ -48,8 +48,15 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// GeometricalObject-based objects (Element or Condition) on the Interface for Searching +/** This class Is the "wrapper" for Elements/Conditions on the interface. It uses the fact that both +* Elements and Conditions are deriving from "GeometricalObject". The search is caarried out using the +* center of the geometry. +* It saves a pointer to the original geometry, not to the Condition/Element itself. This is e.g. why the Id is not accessible. +* It selects the best result by the closest projection distance of the successful projections. +* In case no projection is successful, it uses an approximation (closest node of the geometry with the +* smallest center distance to the point for which a neighbor is to be found) +* Look into the class description of the MapperCommunicator to see how this Object is used in the application */ class InterfaceGeometryObject : public InterfaceObject { @@ -65,7 +72,7 @@ class InterfaceGeometryObject : public InterfaceObject ///@{ /// Default constructor. - InterfaceGeometryObject(Geometry>& rGeometry, const double ApproximationTolerance, const int ConstructionIndex, + InterfaceGeometryObject(Geometry>& rGeometry, const double ApproximationTolerance, const int EchoLevel, const int ConstructionIndex, GeometryData::IntegrationMethod IntegrationMethod = GeometryData::NumberOfIntegrationMethods) : mpGeometry(&rGeometry), mApproximationTolerance(ApproximationTolerance), @@ -73,10 +80,18 @@ class InterfaceGeometryObject : public InterfaceObject mIntegrationMethod(IntegrationMethod) { SetCoordinates(); + mGeometryFamily = mpGeometry->GetGeometryFamily(); + KRATOS_ERROR_IF(mGeometryFamily == GeometryData::Kratos_Point) + << "Elements/Conditions with point-based geometries cannot be used with interpolative " + << "Mapping, use the Nearest Neighbor Mapper instead!" << std::endl; + mNumPoints = mpGeometry->PointsNumber(); KRATOS_ERROR_IF(mNumPoints == 0) << "Number of Points cannot be zero" << std::endl; - mpPoint = &(mpGeometry->GetPoint(0)); + + mpPoint = &(mpGeometry->GetPoint(0)); // used for debugging + + mEchoLevel = EchoLevel; } /// Destructor. @@ -104,7 +119,7 @@ class InterfaceGeometryObject : public InterfaceObject // Distance is the distance to the center and not the projection distance, therefore it is unused bool is_closer = false; bool is_inside = false; - double projection_distance; + double projection_distance = std::numeric_limits::max(); array_1d projection_local_coords; if (mGeometryFamily == GeometryData::Kratos_Linear @@ -137,16 +152,24 @@ class InterfaceGeometryObject : public InterfaceObject projection_distance); } else - { - std::cout << "MAPPER WARNING, Unsupported geometry, " - << "using an approximation" << std::endl; + { + if (mEchoLevel >= 2) { + std::cout << "MAPPER WARNING, Unsupported geometry, " + << "using an approximation (Nearest Node)" + << " | InterfaceGeometryObject, Center: [ " + << this->X() << " | " + << this->Y() << " | " + << this->Z() << " ], " + << "(KratosGeometryFamily \"" << mGeometryFamily + << "\", num points: " << mNumPoints << std::endl; + } return false; } - projection_distance = fabs(projection_distance); - if (is_inside) { + projection_distance = fabs(projection_distance); + if (projection_distance < rMinDistance) { rMinDistance = projection_distance; @@ -313,7 +336,7 @@ class InterfaceGeometryObject : public InterfaceObject Geometry>* mpGeometry; Node<3>* mpPoint; GeometryData::KratosGeometryFamily mGeometryFamily; - int mNumPoints; //TODO check if still needed + int mNumPoints; double mApproximationTolerance = 0.0f; int mConstructionIndex; GeometryData::IntegrationMethod mIntegrationMethod; diff --git a/applications/MappingApplication/custom_utilities/interface_node.h b/applications/MappingApplication/custom_utilities/interface_node.h index e80fdfe96046..e2ad2b0f635f 100644 --- a/applications/MappingApplication/custom_utilities/interface_node.h +++ b/applications/MappingApplication/custom_utilities/interface_node.h @@ -48,8 +48,10 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Node on the Interface for Searching +/** This class Is the "wrapper" for nodes on the interface. It selects the best result by the closest distance to the +* point of which neighbor have to be found +* Look into the class description of the MapperCommunicator to see how this Object is used in the application */ class InterfaceNode : public InterfaceObject { @@ -65,9 +67,10 @@ class InterfaceNode : public InterfaceObject ///@{ /// Default constructor. - InterfaceNode(Node<3>& rNode) : mpNode(&rNode) + InterfaceNode(Node<3>& rNode, const int EchoLevel) : mpNode(&rNode) { SetCoordinates(); + mEchoLevel = EchoLevel; } /// Destructor. diff --git a/applications/MappingApplication/custom_utilities/interface_object.h b/applications/MappingApplication/custom_utilities/interface_object.h index 248f4d6c1a97..ca0e481abba2 100644 --- a/applications/MappingApplication/custom_utilities/interface_object.h +++ b/applications/MappingApplication/custom_utilities/interface_object.h @@ -50,8 +50,15 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Base Class for Searching Objects +/** This class provides a set of functions that is used for identifying the nearest object. +* It is needed such that the bin-search can be used with both nodes and elements/conditions +* The bin search is implemented to work with this kind of object +* It implements the function "EvaluateResult", which is used by the local search to determine which +* of the objects in teh vicinity of a point is the best search result. This function has to be +* implemented by all subclasses. It cannot be made pure virtual, because for remote searching, +* objects of this type have to be created +* Look into the class description of the MapperCommunicator to see how this Object is used in the application */ class InterfaceObject : public Point<3> { @@ -77,12 +84,6 @@ class InterfaceObject : public Point<3> ///@name Life Cycle ///@{ - // TODO hide constructors that are only called from the derived classes - InterfaceObject() : Point<3>(0.0f, 0.0f, 0.0f) // Default Constructor /TODO maybe delete zeros - { - SetInitialValuesToMembers(); - } - InterfaceObject(double X, double Y, double Z) : Point<3>(X, Y, Z) // constuct from coordinates { SetInitialValuesToMembers(); @@ -109,20 +110,7 @@ class InterfaceObject : public Point<3> bool IsInBoundingBox(double* pBoundingBox[]) { - // xmax, xmin, ymax, ymin, zmax, zmin - bool is_inside = false; - - if (this->X() < *pBoundingBox[0] && this->X() > *pBoundingBox[1]) // check x-direction - { - if (this->Y() < *pBoundingBox[2] && this->Y() > *pBoundingBox[3]) // check y-direction - { - if (this->Z() < *pBoundingBox[4] && this->Z() > *pBoundingBox[5]) // check z-direction - { - is_inside = true; - } - } - } - return is_inside; + return MapperUtilities::PointIsInsideBoundingBox(*pBoundingBox, this->Coordinates());; } void ProcessSearchResult(const double Distance, const int PairingStatus, const int Rank) @@ -253,6 +241,7 @@ class InterfaceObject : public Point<3> ///@name Protected member Variables ///@{ + int mEchoLevel = 0; ///@} ///@name Protected Operators @@ -263,6 +252,12 @@ class InterfaceObject : public Point<3> ///@name Protected Operations ///@{ + // This constructor is called by its derived classes + InterfaceObject() : Point<3>(0.0f, 0.0f, 0.0f) + { + SetInitialValuesToMembers(); + } + void SetInitialValuesToMembers() { mMinDistanceNeighbor = std::numeric_limits::max(); diff --git a/applications/MappingApplication/custom_utilities/interface_object_manager_base.h b/applications/MappingApplication/custom_utilities/interface_object_manager_base.h index 36721bbce1b9..caaee0c50f83 100644 --- a/applications/MappingApplication/custom_utilities/interface_object_manager_base.h +++ b/applications/MappingApplication/custom_utilities/interface_object_manager_base.h @@ -66,8 +66,10 @@ struct CandidateManager std::unordered_map > mMatchingInformation; }; -/// Short class definition. -/** Detail class definition. +/// BaseClass for managing the InterfaceObjects +/** This class is the interface between the Searching objects and the InterfaceObjects. It is responsible +* for filling buffers, reconstructing things from buffers and the construction of the InterfaceObjects +* Look into the class description of the MapperCommunicator to see how this Object is used in the application */ class InterfaceObjectManagerBase { @@ -132,7 +134,7 @@ class InterfaceObjectManagerBase for (auto& interface_obj : mInterfaceObjects) { - if (!interface_obj->NeighborOrApproximationFound()) // TODO this prevents from printing warnings in case only an approx is found + if (!interface_obj->NeighborOrApproximationFound()) { all_neighbors_found = 0; } @@ -149,16 +151,16 @@ class InterfaceObjectManagerBase for (auto& interface_obj : mInterfaceObjects) { const int pairing_status = interface_obj->GetPairingStatus(); - if (pairing_status == InterfaceObject::PairingStatus::NoNeighbor) // TODO + if (pairing_status == InterfaceObject::PairingStatus::NoNeighbor) { std::cout << "MAPPER WARNING, Rank " << mCommRank << "\tPoint [ " << interface_obj->X() << " | " << interface_obj->Y() << " | " << interface_obj->Z() << " ] " - << "has not found a neighbor" << std::endl; + << "has not found a neighbor!" << std::endl; } - else if (pairing_status == InterfaceObject::PairingStatus::Approximation) // TODO + else if (pairing_status == InterfaceObject::PairingStatus::Approximation) { std::cout << "MAPPER WARNING, Rank " << mCommRank << "\tPoint [ " @@ -549,7 +551,7 @@ class InterfaceObjectManagerBase int i = 0; for (auto &local_node : rModelPart.GetCommunicator().LocalMesh().Nodes()) { - mInterfaceObjects[i] = InterfaceObject::Pointer( new InterfaceNode(local_node) ); + mInterfaceObjects[i] = InterfaceObject::Pointer( new InterfaceNode(local_node, mEchoLevel) ); ++i; } } @@ -586,23 +588,27 @@ class InterfaceObjectManagerBase { mInterfaceObjects.push_back(InterfaceObject::Pointer( new InterfaceGeometryObject(condition.GetGeometry(), ApproximationTolerance, + mEchoLevel, 0) )); } for (auto& element : rModelPart.GetCommunicator().LocalMesh().Elements()) { mInterfaceObjects.push_back(InterfaceObject::Pointer( new InterfaceGeometryObject(element.GetGeometry(), ApproximationTolerance, + mEchoLevel, 0) )); } } else // construct with condition gauss points { + KRATOS_ERROR << "This is not implemented at the moment" << std::endl; for (auto& condition : rModelPart.GetCommunicator().LocalMesh().Conditions()) { for (int g = 0; g < 111111; ++g) // TODO fix this, should be number of GPs { mInterfaceObjects.push_back(InterfaceObject::Pointer( new InterfaceGeometryObject(condition.GetGeometry(), ApproximationTolerance, + mEchoLevel, g, IntegrationMethod) )); } } @@ -612,6 +618,7 @@ class InterfaceObjectManagerBase { mInterfaceObjects.push_back(InterfaceObject::Pointer( new InterfaceGeometryObject(element.GetGeometry(), ApproximationTolerance, + mEchoLevel, g, IntegrationMethod) )); } } diff --git a/applications/MappingApplication/custom_utilities/interface_object_manager_parallel.h b/applications/MappingApplication/custom_utilities/interface_object_manager_parallel.h index 544c4bab0321..942bef800194 100644 --- a/applications/MappingApplication/custom_utilities/interface_object_manager_parallel.h +++ b/applications/MappingApplication/custom_utilities/interface_object_manager_parallel.h @@ -49,8 +49,11 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// MPI-Parallel Verison of the Entity that manages the InterfaceObjects +/** It implements the functions that are only needed if the mapper is a mpi-parallel mapper. +* These functions are implemented as virtual functions in the BaseClass. Besides handeling +* buffers it also computes the communication graph and the buffer sizes. +* Look into the class description of the MapperCommunicator to see how this Object is used in the application */ class InterfaceObjectManagerParallel : public InterfaceObjectManagerBase { @@ -116,7 +119,7 @@ class InterfaceObjectManagerParallel : public InterfaceObjectManagerBase } } - if (mEchoLevel > 3) + if (mEchoLevel >= 4) { PrintCandidatePartitions(interface_obj, partition_list); // For debugging } @@ -127,7 +130,7 @@ class InterfaceObjectManagerParallel : public InterfaceObjectManagerBase if (!interface_obj->GetIsBeingSent()) { // Send interface_obj to all Partitions - if (mEchoLevel > 1) + if (mEchoLevel >= 2) { std::cout << "MAPPER WARNING, Rank " << mCommRank << ", interface_obj [ " diff --git a/applications/MappingApplication/custom_utilities/interface_object_manager_serial.h b/applications/MappingApplication/custom_utilities/interface_object_manager_serial.h index 8ba8d864ca0b..4e15a9919c4f 100644 --- a/applications/MappingApplication/custom_utilities/interface_object_manager_serial.h +++ b/applications/MappingApplication/custom_utilities/interface_object_manager_serial.h @@ -48,8 +48,10 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Serial Verison of the Entity that manages the InterfaceObjects +/** It implements the functions that are only needed if the mapper is a serial +* mapper. These functions are implemented as virtual functions in the BaseClass +* Look into the class description of the MapperCommunicator to see how this Object is used in the application */ class InterfaceObjectManagerSerial : public InterfaceObjectManagerBase { diff --git a/applications/MappingApplication/custom_utilities/interface_search_structure.h b/applications/MappingApplication/custom_utilities/interface_search_structure.h index 56ec6fc77f1f..38a156cde068 100644 --- a/applications/MappingApplication/custom_utilities/interface_search_structure.h +++ b/applications/MappingApplication/custom_utilities/interface_search_structure.h @@ -53,8 +53,12 @@ typedef matrix GraphType; // GraphColoringProcess ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Rank local searching +/** This class provides features for rank local searching. It is basically a wrapper for the Bin Search Function +* It computes local neighbors and selects the best neighbor out of the search results. How these are selected is +* defined in the "EvaluateResult" function of the InterfaceObject +* If no neighbors are found, the search radius is increased by a factor ("increase_factor" in "Search") +* Look into the class description of the MapperCommunicator to see how this Object is used in the application */ class InterfaceSearchStructure { @@ -97,7 +101,7 @@ class InterfaceSearchStructure { mSearchRadius = SearchRadius; mMaxSearchIterations = MaxSearchIterations; - int increase_factor = 4; + const int increase_factor = 4; int num_iteration = 1; bool last_iteration = false; @@ -124,7 +128,7 @@ class InterfaceSearchStructure last_iteration = true; } - if (mEchoLevel > 1 && mCommRank == 0) + if (mEchoLevel >= 2 && mCommRank == 0) { std::cout << "MAPPER WARNING, search radius was increased, " << "another search iteration is conducted, " @@ -135,7 +139,7 @@ class InterfaceSearchStructure ConductSearchIteration(last_iteration); } - if (mEchoLevel > 1) + if (mEchoLevel >= 2) { mpInterfaceObjectManager->CheckResults(); } diff --git a/applications/MappingApplication/custom_utilities/interface_search_structure_mpi.h b/applications/MappingApplication/custom_utilities/interface_search_structure_mpi.h index 5e6ebe90da8d..4a5209c91bb9 100644 --- a/applications/MappingApplication/custom_utilities/interface_search_structure_mpi.h +++ b/applications/MappingApplication/custom_utilities/interface_search_structure_mpi.h @@ -23,6 +23,7 @@ // Project includes #include "interface_search_structure.h" #include "interface_object_manager_parallel.h" +#include "mapper_utilities.h" #include "mapper_utilities_mpi.h" @@ -51,8 +52,13 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// MPI-parallel searching +/** This class provides features for remote searching. It first computes candidate partitions +* (partitions in the vicinity of a point), where possible neighbors can be. +* It then send the objects for which neighbors are to be found to the corresponding candidate partitions +* In the candidate partitions (can be either local or remote), a local search is conducted (see BaseClass) +* The results are sent back to the partition where the object is local, and the best result is then chosen. +* Look into the class description of the MapperCommunicator to see how this Object is used in the application */ class InterfaceSearchStructureMPI : public InterfaceSearchStructure { @@ -77,7 +83,7 @@ class InterfaceSearchStructureMPI : public InterfaceSearchStructure mCommRank = CommRank; mCommSize = CommSize; - MapperUtilitiesMPI::ComputeLocalBoundingBox(rModelPartBins, + MapperUtilities::ComputeLocalBoundingBox(rModelPartBins, mLocalBoundingBox); } @@ -243,7 +249,7 @@ class InterfaceSearchStructureMPI : public InterfaceSearchStructure MapperUtilitiesMPI::ComputeColoringGraph(local_comm_list, mCommSize, rDomainsColoredGraph, rMaxColors); // Output the colored Graph - if (mCommRank == 0 && mEchoLevel > 2) + if (mCommRank == 0 && mEchoLevel >= 3) { MapperUtilitiesMPI::PrintGraph(rDomainsColoredGraph, rMaxColors); } @@ -376,7 +382,7 @@ class InterfaceSearchStructureMPI : public InterfaceSearchStructure mDomainsColoredGraph = rDomainsColoredGraph; // save it for the mapping mMaxColors = rMaxColors; // Output the colored Graph - if (mCommRank == 0 && mEchoLevel > 2) + if (mCommRank == 0 && mEchoLevel >= 3) { MapperUtilitiesMPI::PrintGraph(rDomainsColoredGraph, rMaxColors); } diff --git a/applications/MappingApplication/custom_utilities/mapper.h b/applications/MappingApplication/custom_utilities/mapper.h index b9dd8e54f7b5..a2e503d29831 100644 --- a/applications/MappingApplication/custom_utilities/mapper.h +++ b/applications/MappingApplication/custom_utilities/mapper.h @@ -55,7 +55,19 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. +/// Base Class for all Mappers +/** This is the base class for every mapper. +* It contains the three pure virtual functions that have to be implemented by every mapper: +* - Map: Basic function that maps a field from one ModelPart to another Modelpart +* Mapping Direction: Origin => Destionation +* - InverseMap: This function does the opposite of the "Map" function +* Mapping Direction: Destination => Origin +* - UpdateInterface: Called when the interface is changed. It recomputes the neighbors and +* other information related to the relations btw entities (node, elements,...) on the interfaces +* It is also responsible for initializing the MapperCommunicator or the MapperMPICommuniator +* For information abt the available echo_levels and the JSON default-parameters +* look into the class description of the MapperCommunicator +*/ class Mapper { @@ -190,8 +202,6 @@ class Mapper ComputeNumberOfNodesAndConditions(); - mEchoLevel = JsonParameters["echo_level"].GetInt(); - // Create the mapper communicator #ifdef KRATOS_USING_MPI // mpi-parallel compilation int mpi_initialized; @@ -220,6 +230,9 @@ class Mapper #else // serial compilation InitializeSerialCommunicator(); #endif + // Access the Parameters only after the communicator is constructed, + // bcs they are checked and validated there! + mEchoLevel = JsonParameters["echo_level"].GetInt(); } void ComputeNumberOfNodesAndConditions() diff --git a/applications/MappingApplication/custom_utilities/mapper_communicator.h b/applications/MappingApplication/custom_utilities/mapper_communicator.h index da6823cba236..3506ebe78266 100644 --- a/applications/MappingApplication/custom_utilities/mapper_communicator.h +++ b/applications/MappingApplication/custom_utilities/mapper_communicator.h @@ -51,8 +51,30 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Interface btw the Mappers and the Core of the MappingApplication +/** This class is the top instance of the Core of the MappingApplication +* It handles the searching and the exchange of Data btw the Interfaces +* It also checks and validates the JSON input (default-parameters: +* memeber variable "mDefaultParameters"). +* +* Available Echo Levels: +* 0 : Mute every output +* == 1 : Print Timing Information (Mapper Construction and the three basic functions) +* >= 2 : Warnings are printed +* >= 3 : Basic Information, recommended for standard debugging +* >= 4 : Very detailed output for every object on the interface! +* (Only recommended for debugging of small example, otherwise it gets very messy! +* Should be only needed for developing) +* +* Structure of the how the different classes work with each other: +* (Illustrated in Thesis mentioned in the header) +* It is described in the serial case, if executed mpi-parallel, the MPI-versions +* of the classes are used: +* MapperCommunicator +* Constructs the InterfaceObjectManagers both for the Destination and the Origin +* Which InterfaceObjects should be used is declared in the input of the "Initialize*" functions +* It then constructs the SearchStructure and initializes the Search +* For the exchange of values it implements the corresponding functions */ class MapperCommunicator { @@ -68,16 +90,20 @@ class MapperCommunicator ///@{ MapperCommunicator(ModelPart& rModelPartOrigin, ModelPart& rModelPartDestination, - Parameters& rJsonParameters) : + Parameters JsonParameters, const int CommRank = 0) : mrModelPartOrigin(rModelPartOrigin), - mrModelPartDestination(rModelPartDestination) + mrModelPartDestination(rModelPartDestination), + mJsonParameters(JsonParameters) { + CheckAndValidateJson(CommRank); - mInitialSearchRadius = rJsonParameters["search_radius"].GetDouble(); - mMaxSearchIterations = rJsonParameters["search_iterations"].GetInt(); - mApproximationTolerance = rJsonParameters["approximation_tolerance"].GetDouble(); + mInitialSearchRadius = mJsonParameters["search_radius"].GetDouble(); + mMaxSearchIterations = mJsonParameters["search_iterations"].GetInt(); + mApproximationTolerance = mJsonParameters["approximation_tolerance"].GetDouble(); - mEchoLevel = rJsonParameters["echo_level"].GetInt(); + mEchoLevel = mJsonParameters["echo_level"].GetInt(); + + CheckInterfaceModelParts(CommRank); } /// Destructor. @@ -105,7 +131,7 @@ class MapperCommunicator mEchoLevel, mApproximationTolerance) ); - if (mEchoLevel > 3) + if (mEchoLevel >= 4) { mpInterfaceObjectManagerOrigin->PrintInterfaceObjects("Origin"); } @@ -127,7 +153,7 @@ class MapperCommunicator mEchoLevel, mApproximationTolerance) ); - if (mEchoLevel > 3) + if (mEchoLevel >= 4) { mpInterfaceObjectManagerDestination->PrintInterfaceObjects("Destination"); } @@ -331,6 +357,17 @@ class MapperCommunicator ///@name Member Variables ///@{ + Parameters mJsonParameters; + Parameters mDefaultParameters = Parameters( R"( + { + "mapper_type" : "", + "interface_submodel_part_origin" : "", + "interface_submodel_part_destination" : "", + "search_radius" : -1.0, + "search_iterations" : 3, + "approximation_tolerance" : -1.0, + "echo_level" : 0 + } )" ); ///@} ///@name Private Operators @@ -352,9 +389,149 @@ class MapperCommunicator { mpSearchStructure->Search(InitialSearchRadius, MaxSearchIterations); - if (mEchoLevel > 3) + if (mEchoLevel >= 4) { - PrintPairs(); + // PrintPairs(); // TODO reimplement! + } + } + + // CommRank is used as input bcs the MyPID function of the non-MPI MapperCommunicator is used + // since this function is called before the MapperMPICommunicato is initialized + void CheckAndValidateJson(const int CommRank) + { + // Check if there is a valid input for the search parameters + bool compute_search_radius = true; + if (mJsonParameters.Has("search_radius")) + { + compute_search_radius = false; + + if (mJsonParameters["search_radius"].GetDouble() < 0.0f) + { + KRATOS_ERROR << "Invalid Search Radius specified" << std::endl; + } + } + + if (mJsonParameters.Has("search_iterations")) + { + if (mJsonParameters["search_iterations"].GetInt() < 1) + { + KRATOS_ERROR << "Number of specified Search Iterations too small" << std::endl; + } + } + + if (mJsonParameters.Has("approximation_tolerance")) + { + if (mJsonParameters["approximation_tolerance"].GetDouble() < 0.0f) + { + KRATOS_ERROR << "Invalid Tolerance for Approximations specified" << std::endl; + } + } + + if (mJsonParameters.Has("echo_level")) + { + if (mJsonParameters["echo_level"].GetInt() < 0) + { + KRATOS_ERROR << "Echo Level cannot be smaller than 0" << std::endl; + } + + if (mJsonParameters["echo_level"].GetInt() >= 3 && CommRank == 0) + { + std::cout << "Mapper JSON Parameters BEFORE validation:\n " + << mJsonParameters.PrettyPrintJsonString() << std::endl; + } + } + + mJsonParameters.RecursivelyValidateAndAssignDefaults(mDefaultParameters); + + if (mJsonParameters["echo_level"].GetInt() >= 3 && CommRank == 0) + { + std::cout << "Mapper JSON Parameters AFTER validation:\n " + << mJsonParameters.PrettyPrintJsonString() << std::endl; + } + + // Compute the search radius in case it was not specified + if (compute_search_radius) + { + double search_radius = MapperUtilities::ComputeSearchRadius(mrModelPartOrigin, + mrModelPartDestination, + mJsonParameters["echo_level"].GetInt()); + mJsonParameters["search_radius"].SetDouble(search_radius); + + if (mJsonParameters["echo_level"].GetInt() >= 3 && CommRank == 0) + { + std::cout << "SearchRadius computed by MapperCommunicator = " << search_radius << std::endl; + } + } + + if (mJsonParameters["approximation_tolerance"].GetDouble() < 0.0f) // nothing specified, set to max + { + mJsonParameters["approximation_tolerance"].SetDouble(std::numeric_limits::max()); + } + } + + // CommRank is used as input bcs the MyPID function of the non-MPI MapperCommunicator is used + // since this function is called before the MapperMPICommunicato is initialized + void CheckInterfaceModelParts(const int CommRank) + { + const int num_nodes_origin = MapperUtilities::ComputeNumberOfNodes(mrModelPartOrigin); + const int num_conditions_origin = MapperUtilities::ComputeNumberOfConditions(mrModelPartOrigin); + const int num_elements_origin = MapperUtilities::ComputeNumberOfElements(mrModelPartOrigin); + + const int num_nodes_destination = MapperUtilities::ComputeNumberOfNodes(mrModelPartDestination); + const int num_conditions_destination = MapperUtilities::ComputeNumberOfConditions(mrModelPartDestination); + const int num_elements_destination = MapperUtilities::ComputeNumberOfElements(mrModelPartDestination); + + // Check if the ModelPart contains entities + if (num_nodes_origin + num_conditions_origin + num_elements_origin < 1) + { + KRATOS_ERROR << "Neither Nodes nor Conditions nor Elements found " + << "in the Origin ModelPart" << std::endl; + } + + if (num_nodes_destination + num_conditions_destination + num_elements_destination < 1) + { + KRATOS_ERROR << "Neither Nodes nor Conditions nor Elements found " + << "in the Destination ModelPart" << std::endl; + } + + // Check if the inpt ModelParts contain both Elements and Conditions + // This is NOT possible, bcs the InterfaceObjects are constructed + // with whatever exists in the Modelpart (see the InterfaceObjectManagerBase, + // function "InitializeInterfaceGeometryObjectManager") + if (num_conditions_origin > 0 && num_elements_origin > 0) + { + KRATOS_ERROR << "Origin ModelPart contains both Conditions and Elements " + << "which is not permitted" << std::endl; + } + + if (num_conditions_destination > 0 && num_elements_destination > 0) + { + KRATOS_ERROR << "Destination ModelPart contains both Conditions and Elements " + << "which is not permitted" << std::endl; + } + + if (mEchoLevel >= 2) { + std::vector model_part_origin_bbox = MapperUtilities::ComputeModelPartBoundingBox(mrModelPartOrigin); + std::vector model_part_destination_bbox = MapperUtilities::ComputeModelPartBoundingBox(mrModelPartDestination); + + bool bbox_overlapping = MapperUtilities::ComputeBoundingBoxIntersection( + model_part_origin_bbox, + model_part_destination_bbox); + if(CommRank == 0) + { + if (!bbox_overlapping) { + std::cout << "MAPPER WARNING, the bounding boxes of the " + << "Modelparts do not overlap! " + << MapperUtilities::PrintModelPartBoundingBoxes(model_part_origin_bbox, + model_part_destination_bbox) + << std::endl; + } else if (mEchoLevel >= 3) + { + std::cout << MapperUtilities::PrintModelPartBoundingBoxes(model_part_origin_bbox, + model_part_destination_bbox) + << std::endl; + } + } } } diff --git a/applications/MappingApplication/custom_utilities/mapper_factory.h b/applications/MappingApplication/custom_utilities/mapper_factory.h index 9b304a7b69ce..22de1c3e15ab 100644 --- a/applications/MappingApplication/custom_utilities/mapper_factory.h +++ b/applications/MappingApplication/custom_utilities/mapper_factory.h @@ -52,8 +52,12 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Python Interface of the MappingApplication +/** This class constructs the mappers and exposes them to Python +* Some checks are performed to see if the Input (ModelParts and JSON-Parameters) are valid +* Also the additional timing information is implemented here (echo_level = 1) +* For information abt the available echo_levels and the JSON default-parameters +* look into the class description of the MapperCommunicator */ class MapperFactory { @@ -70,14 +74,12 @@ class MapperFactory /// Default constructor. MapperFactory(ModelPart& rModelPartOrigin, ModelPart& rModelPartDestination, - Parameters& rJsonParameters) : + Parameters JsonParameters) : mrModelPartOrigin(rModelPartOrigin), mrModelPartDestination(rModelPartDestination), - mrJsonParameters(rJsonParameters) + mJsonParameters(JsonParameters) { - - CheckAndValidateJson(); - ReadAndCheckInterfaceModelParts(); + ReadInterfaceModelParts(); ConstructMapper(); } @@ -258,19 +260,7 @@ class MapperFactory ModelPart* mpInterfaceModelPartOrigin; ModelPart* mpInterfaceModelPartDestination; - Parameters& mrJsonParameters; - Parameters mDefaultParameters = Parameters( R"( - { - "mapper_type" : "", - "interface_submodel_part_origin" : "", - "interface_submodel_part_destination" : "", - "search_radius" : -1.0, - "search_iterations" : 3, - "approximation_tolerance" : -1.0, - "echo_level" : 0 - } )" ); - - bool mComputeSearchRadius; + Parameters mJsonParameters; ///@} ///@name Private Operators @@ -281,167 +271,111 @@ class MapperFactory ///@name Private Operations ///@{ - void CheckAndValidateJson() + void ReadInterfaceModelParts() { - // Check if the three basic parameters are present - if (!mrJsonParameters.Has("mapper_type")) + int echo_level = 0; + // read the echo_level temporarily, bcs the mJsonParameters have not yet been validated and defaults assigned + if (mJsonParameters.Has("echo_level")) { - KRATOS_ERROR << "No \"mapper_type\" defined in json" << std::endl; + echo_level = std::max(echo_level, mJsonParameters["echo_level"].GetInt()); } - mMapperType = mrJsonParameters["mapper_type"].GetString(); + int comm_rank_origin = mrModelPartOrigin.GetCommunicator().MyPID(); + int comm_rank_destination = mrModelPartDestination.GetCommunicator().MyPID(); - if (!mrJsonParameters.Has("interface_submodel_part_origin")) + if (mJsonParameters.Has("interface_submodel_part_origin")) { - KRATOS_ERROR << "No \"interface_submodel_part_origin\" " - << "defined in json" << std::endl; - } - - if (!mrJsonParameters.Has("interface_submodel_part_destination")) - { - KRATOS_ERROR << "No \"interface_submodel_part_destination\" " - << "defined in json" << std::endl; - } + std::string name_interface_submodel_part = mJsonParameters["interface_submodel_part_origin"].GetString(); + mpInterfaceModelPartOrigin = &mrModelPartOrigin.GetSubModelPart(name_interface_submodel_part); - // Check if there is a valid input for the search parameters - mComputeSearchRadius = true; - if (mrJsonParameters.Has("search_radius")) - { - mComputeSearchRadius = false; - - if (mrJsonParameters["search_radius"].GetDouble() < 0.0f) + if (echo_level >= 3 && comm_rank_origin == 0) { - KRATOS_ERROR << "Invalid Search Radius specified" << std::endl; + std::cout << "Mapper: SubModelPart used for Origin-ModelPart" << std::endl; } } - - if (mrJsonParameters.Has("search_iterations")) + else { - if (mrJsonParameters["search_iterations"].GetInt() < 1) + mpInterfaceModelPartOrigin = &mrModelPartOrigin; + + if (echo_level >= 3 && comm_rank_origin == 0) { - KRATOS_ERROR << "Number of specified Search Iterations too small" << std::endl; + std::cout << "Mapper: Main ModelPart used for Origin-ModelPart" << std::endl; } } - if (mrJsonParameters.Has("approximation_tolerance")) + if (mJsonParameters.Has("interface_submodel_part_destination")) { - if (mrJsonParameters["mapper_type"].GetString() == "NearestNeighbor") - { - KRATOS_ERROR << "Invalid Parameter \"approximation_tolerance\" " - << "specified for Nearest Neighbor Mapper" << std::endl; - } - if (mrJsonParameters["approximation_tolerance"].GetDouble() < 0.0f) + std::string name_interface_submodel_part = mJsonParameters["interface_submodel_part_destination"].GetString(); + mpInterfaceModelPartDestination = &mrModelPartDestination.GetSubModelPart(name_interface_submodel_part); + + if (echo_level >= 3 && comm_rank_destination == 0) { - KRATOS_ERROR << "Invalid Tolerance for Approximations specified" << std::endl; + std::cout << "Mapper: SubModelPart used for Destination-ModelPart" << std::endl; } } - - if (mrJsonParameters.Has("echo_level")) + else { - if (mrJsonParameters["echo_level"].GetInt() < 0) + mpInterfaceModelPartDestination = &mrModelPartDestination; + + if (echo_level >= 3 && comm_rank_destination == 0) { - KRATOS_ERROR << "Echo Level cannot be smaller than 0" << std::endl; + std::cout << "Mapper: Main ModelPart used for Destination-ModelPart" << std::endl; } } - - mrJsonParameters.RecursivelyValidateAndAssignDefaults(mDefaultParameters); - - if (mrJsonParameters["approximation_tolerance"].GetDouble() < 0.0f) // nothing specified, set to max - { - mrJsonParameters["approximation_tolerance"].SetDouble(std::numeric_limits::max()); - } } - void ReadAndCheckInterfaceModelParts() + void ConstructMapper() { - std::string name_interface_submodel_part = mrJsonParameters["interface_submodel_part_origin"].GetString(); - mpInterfaceModelPartOrigin = &mrModelPartOrigin.GetSubModelPart(name_interface_submodel_part); - - name_interface_submodel_part = mrJsonParameters["interface_submodel_part_destination"].GetString(); - mpInterfaceModelPartDestination = &mrModelPartDestination.GetSubModelPart(name_interface_submodel_part); - - const int num_nodes_origin = MapperUtilities::ComputeNumberOfNodes(*mpInterfaceModelPartOrigin); - const int num_conditions_origin = MapperUtilities::ComputeNumberOfConditions(*mpInterfaceModelPartOrigin); - const int num_elements_origin = MapperUtilities::ComputeNumberOfElements(*mpInterfaceModelPartOrigin); - - const int num_nodes_destination = MapperUtilities::ComputeNumberOfNodes(*mpInterfaceModelPartDestination); - const int num_conditions_destination = MapperUtilities::ComputeNumberOfConditions(*mpInterfaceModelPartDestination); - const int num_elements_destination = MapperUtilities::ComputeNumberOfElements(*mpInterfaceModelPartDestination); - - // Check if the ModelPart contains entities - if (num_nodes_origin + num_conditions_origin + num_elements_origin < 1) - { - KRATOS_ERROR << "Neither Nodes nor Conditions nor Elements found " - << "in the Origin ModelPart" << std::endl; - } - - if (num_conditions_origin > 0 && num_elements_origin > 0) - { - KRATOS_ERROR << "Origin ModelPart contains both Conditions and Elements " - << "which is not permitted" << std::endl; - } - - if (num_nodes_destination + num_conditions_destination + num_elements_destination < 1) - { - KRATOS_ERROR << "Neither Nodes nor Conditions nor Elements found " - << "in the Destination ModelPart" << std::endl; - } - - if (num_conditions_destination > 0 && num_elements_destination > 0) - { - KRATOS_ERROR << "Destination ModelPart contains both Conditions and Elements " - << "which is not permitted" << std::endl; - } + double start_time = MapperUtilities::GetCurrentTime(); - // Compute the search radius in case it was not specified, can only be done after the modelparts are read - if (mComputeSearchRadius) + if (!mJsonParameters.Has("mapper_type")) { - double search_radius = MapperUtilities::ComputeSearchRadius(*mpInterfaceModelPartOrigin, - *mpInterfaceModelPartDestination, - mrJsonParameters["echo_level"].GetInt()); - mrJsonParameters["search_radius"].SetDouble(search_radius); + KRATOS_ERROR << "No \"mapper_type\" defined in json" << std::endl; } - } - void ConstructMapper() - { - double start_time = MapperUtilities::GetCurrentTime(); + mMapperType = mJsonParameters["mapper_type"].GetString(); if (mMapperType == "NearestNeighbor") { + if (mJsonParameters.Has("approximation_tolerance")) + { + KRATOS_ERROR << "Invalid Parameter \"approximation_tolerance\" " + << "specified for Nearest Neighbor Mapper" << std::endl; + } + mpMapper = Mapper::Pointer(new NearestNeighborMapper(*mpInterfaceModelPartOrigin, *mpInterfaceModelPartDestination, - mrJsonParameters)); + mJsonParameters)); } else if (mMapperType == "NearestElement") { mpMapper = Mapper::Pointer(new NearestElementMapper(*mpInterfaceModelPartOrigin, *mpInterfaceModelPartDestination, - mrJsonParameters)); + mJsonParameters)); } /*else if (mMapperType == "Barycentric") { mpMapper = Mapper::Pointer(new BarycentricMapper(*mpInterfaceModelPartOrigin, *mpInterfaceModelPartDestination, - mrJsonParameters)); + mJsonParameters)); } *//*else if (mMapperType == "RBF") { mpMapper = Mapper::Pointer(new RBFMapper(*mpInterfaceModelPartOrigin, *mpInterfaceModelPartDestination, - mrJsonParameters)); + mJsonParameters)); } *//*else if (mMapperType == "Mortar") { mpMapper = Mapper::Pointer(new MortarMapper(*mpInterfaceModelPartOrigin, *mpInterfaceModelPartDestination, - mrJsonParameters)); + mJsonParameters)); } *//*else if (mMapperType == "IGA") { mpMapper = Mapper::Pointer(new IGAMapper(*mpInterfaceModelPartOrigin, *mpInterfaceModelPartDestination, - mrJsonParameters)); + mJsonParameters)); } */else { - KRATOS_ERROR << "Selected Mapper not implemented" << std::endl; + KRATOS_ERROR << "Selected Mapper \"" << mMapperType << "\" not implemented" << std::endl; } double elapsed_time = MapperUtilities::GetCurrentTime() - start_time; @@ -449,7 +383,6 @@ class MapperFactory mpMapper->pGetMapperCommunicator()->PrintTime(mMapperType, "Mapper Construction", elapsed_time); - } ///@} diff --git a/applications/MappingApplication/custom_utilities/mapper_flags.h b/applications/MappingApplication/custom_utilities/mapper_flags.h index 335ff8e70970..76e3761a0733 100644 --- a/applications/MappingApplication/custom_utilities/mapper_flags.h +++ b/applications/MappingApplication/custom_utilities/mapper_flags.h @@ -49,8 +49,9 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Flags needed used in the MappingApplication +/** This class implements the flags needed in the MappingApplication. +* Some of them are exposed to Python */ class MapperFlags { diff --git a/applications/MappingApplication/custom_utilities/mapper_mpi_communicator.h b/applications/MappingApplication/custom_utilities/mapper_mpi_communicator.h index 28a503fe22ba..dd56172ed519 100644 --- a/applications/MappingApplication/custom_utilities/mapper_mpi_communicator.h +++ b/applications/MappingApplication/custom_utilities/mapper_mpi_communicator.h @@ -53,8 +53,10 @@ typedef matrix GraphType; // GraphColoringProcess ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// MPI-parallel version of the MapperCommunicator +/** This class inherits from MapperCommunicator and provides additional Functionalities that are needed +* for MPI-parallel execution +* Look into the class description of the MapperCommunicator to see how this Object is used in the application */ class MapperMPICommunicator : public MapperCommunicator { @@ -70,8 +72,8 @@ class MapperMPICommunicator : public MapperCommunicator ///@{ MapperMPICommunicator(ModelPart& rModelPartOrigin, ModelPart& rModelPartDestination, - Parameters& rJsonParameters) : - MapperCommunicator(rModelPartOrigin, rModelPartDestination, rJsonParameters) { } + Parameters JsonParameters) : + MapperCommunicator(rModelPartOrigin, rModelPartDestination, JsonParameters, MyPID()) { } /// Destructor. virtual ~MapperMPICommunicator() { } @@ -98,7 +100,7 @@ class MapperMPICommunicator : public MapperCommunicator mEchoLevel, mApproximationTolerance) ); - if (mEchoLevel > 3) + if (mEchoLevel >= 4) { mpInterfaceObjectManagerOrigin->PrintInterfaceObjects("Origin"); } @@ -119,7 +121,7 @@ class MapperMPICommunicator : public MapperCommunicator mEchoLevel, mApproximationTolerance) ); - if (mEchoLevel > 3) + if (mEchoLevel >= 4) { mpInterfaceObjectManagerDestination->PrintInterfaceObjects("Destination"); } @@ -284,9 +286,9 @@ class MapperMPICommunicator : public MapperCommunicator mMaxReceiveBufferSize, mColoredGraph, mMaxColors); - if (mEchoLevel > 3) + if (mEchoLevel >= 4) { - PrintPairs(); + // PrintPairs(); // TODO reimplement! } } diff --git a/applications/MappingApplication/custom_utilities/mapper_utilities.h b/applications/MappingApplication/custom_utilities/mapper_utilities.h index 58f64e5851fa..a521234b0ba0 100644 --- a/applications/MappingApplication/custom_utilities/mapper_utilities.h +++ b/applications/MappingApplication/custom_utilities/mapper_utilities.h @@ -54,8 +54,8 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Auxiliary functions for the MappingApplication +/** This class provides a set of auxiliary functions that are used by several other functions / classes */ class MapperUtilities { @@ -207,10 +207,10 @@ class MapperUtilities } else { - if (EchoLevel > 1 && rModelPart.GetCommunicator().MyPID() == 0) + if (EchoLevel >= 2 && rModelPart.GetCommunicator().MyPID() == 0) std::cout << "MAPPER WARNING, no conditions/elements for search radius " << "computations in ModelPart \"" << rModelPart.Name() << "\" found, " - << "using nodes (less efficient)" << std::endl; + << "using nodes (less efficient, bcs search radius will be larger)" << std::endl; max_element_size = ComputeMaxEdgeLengthLocal(rModelPart.GetCommunicator().LocalMesh().Nodes()); } @@ -228,6 +228,139 @@ class MapperUtilities return NumNodesOrigin / NumNodesDestination; } + // ********************************************************************** + // Functions related to Bounding Boxes ********************************** + // ********************************************************************** + static void ComputeLocalBoundingBox(ModelPart& rModelPart, + double* pLocalBoundingBox) + { + // xmax, xmin, ymax, ymin, zmax, zmin + // loop over all nodes (local and ghost(necessary if conditions have only ghost nodes) ) + for (auto &r_node : rModelPart.Nodes()) + { + pLocalBoundingBox[0] = std::max(r_node.X(), pLocalBoundingBox[0]); + pLocalBoundingBox[1] = std::min(r_node.X(), pLocalBoundingBox[1]); + pLocalBoundingBox[2] = std::max(r_node.Y(), pLocalBoundingBox[2]); + pLocalBoundingBox[3] = std::min(r_node.Y(), pLocalBoundingBox[3]); + pLocalBoundingBox[4] = std::max(r_node.Z(), pLocalBoundingBox[4]); + pLocalBoundingBox[5] = std::min(r_node.Z(), pLocalBoundingBox[5]); + } + } + + static void ComputeBoundingBoxWithTolerance(double* pLocalBoundingBox, + const double Tolerance, + double* pLocalBoundingBoxWithTolerance) + { + // xmax, xmin, ymax, ymin, zmax, zmin + pLocalBoundingBoxWithTolerance[0] = pLocalBoundingBox[0] + Tolerance; + pLocalBoundingBoxWithTolerance[1] = pLocalBoundingBox[1] - Tolerance; + pLocalBoundingBoxWithTolerance[2] = pLocalBoundingBox[2] + Tolerance; + pLocalBoundingBoxWithTolerance[3] = pLocalBoundingBox[3] - Tolerance; + pLocalBoundingBoxWithTolerance[4] = pLocalBoundingBox[4] + Tolerance; + pLocalBoundingBoxWithTolerance[5] = pLocalBoundingBox[5] - Tolerance; + } + + static std::vector ComputeModelPartBoundingBox(ModelPart& rModelPart){ + double init_max = std::numeric_limits::max(); + double init_min = std::numeric_limits::lowest(); + + std::vector model_part_bbox{ init_min, init_max, init_min, init_max, init_min, init_max }; + // xmax, xmin, ymax, ymin, zmax, zmin + MapperUtilities::ComputeLocalBoundingBox(rModelPart, &model_part_bbox[0]); + + // this is not the most efficient way, but it is less implementational + // effort and anyway only used for debugging + rModelPart.GetCommunicator().MaxAll(model_part_bbox[0]); + rModelPart.GetCommunicator().MinAll(model_part_bbox[1]); + rModelPart.GetCommunicator().MaxAll(model_part_bbox[2]); + rModelPart.GetCommunicator().MinAll(model_part_bbox[3]); + rModelPart.GetCommunicator().MaxAll(model_part_bbox[4]); + rModelPart.GetCommunicator().MinAll(model_part_bbox[5]); + + return model_part_bbox; + } + + static bool ComputeBoundingBoxIntersection(std::vector& bbox_origin, + std::vector& bbox_destination) + { + std::vector bbox_origin_tol(6); + std::vector bbox_destination_tol(6); + + const double tolerance = std::numeric_limits::epsilon(); + + MapperUtilities::ComputeBoundingBoxWithTolerance(&bbox_origin[0], tolerance, &bbox_origin_tol[0]); + MapperUtilities::ComputeBoundingBoxWithTolerance(&bbox_destination[0], tolerance, &bbox_destination_tol[0]); + + // xmax, xmin, ymax, ymin, zmax, zmin + + // check destination bbox corner points in origin bbox + // check lower point + Point<3> point_to_check_1(bbox_destination[1], bbox_destination[3], bbox_destination[5]); + if (MapperUtilities::PointIsInsideBoundingBox(&bbox_origin_tol[0], point_to_check_1)) + return true; + // check higher point + Point<3> point_to_check_2(bbox_destination[0], bbox_destination[2], bbox_destination[4]); + if (MapperUtilities::PointIsInsideBoundingBox(&bbox_origin_tol[0], point_to_check_2)) + return true; + + // check origin bbox corner points in destination bbox + // check lower point + Point<3> point_to_check_3(bbox_origin[1], bbox_origin[3], bbox_origin[5]); + if (MapperUtilities::PointIsInsideBoundingBox(&bbox_destination_tol[0], point_to_check_3)) + return true; + // check higher point + Point<3> point_to_check_4(bbox_origin[0], bbox_origin[2], bbox_origin[4]); + if (MapperUtilities::PointIsInsideBoundingBox(&bbox_destination_tol[0], point_to_check_4)) + return true; + + return false; + } + + static bool PointIsInsideBoundingBox(double* BoundingBox, + const Point<3>& rPoint) + { // The Bounding Box should have some tolerance already! + bool is_inside = false; + if (rPoint.X() < BoundingBox[0] && rPoint.X() > BoundingBox[1]) // check x-direction + { + if (rPoint.Y() < BoundingBox[2] && rPoint.Y() > BoundingBox[3]) // check y-direction + { + if (rPoint.Z() < BoundingBox[4] && rPoint.Z() > BoundingBox[5]) // check z-direction + { + is_inside = true; + } + } + } + return is_inside; + } + + static std::string PrintModelPartBoundingBoxes(std::vector& bbox_origin, + std::vector& bbox_destination) + { + std::stringstream buffer; + buffer << "Bounding Box Origin: " + << MapperUtilities::BoundingBoxStingStream(&bbox_origin[0]) << ", " + << "Bounding Box Destination: " + << MapperUtilities::BoundingBoxStingStream(&bbox_destination[0]) + << std::endl; + return buffer.str(); + } + + static std::string BoundingBoxStingStream(double* pBoundingBox) + { + // xmax, xmin, ymax, ymin, zmax, zmin + std::stringstream buffer; + buffer << "[" << pBoundingBox[1] << " " // xmin + << pBoundingBox[3] << " " // ymin + << pBoundingBox[5] << "]|[" // zmin + << pBoundingBox[0] << " " // xmax + << pBoundingBox[2] << " " // ymax + << pBoundingBox[4] << "]"; // zmax + return buffer.str(); + } + + // ********************************************************************** + // Functions related to Projection ************************************** + // ********************************************************************** static bool ProjectPointToLine(const Geometry>* pGeometry, const array_1d& GlobalCoords, array_1d& rLocalCoords, diff --git a/applications/MappingApplication/custom_utilities/mapper_utilities_mpi.h b/applications/MappingApplication/custom_utilities/mapper_utilities_mpi.h index 6dc1a7d0f652..4632bfeb034a 100644 --- a/applications/MappingApplication/custom_utilities/mapper_utilities_mpi.h +++ b/applications/MappingApplication/custom_utilities/mapper_utilities_mpi.h @@ -24,6 +24,7 @@ // Project includes #include "includes/define.h" +#include "mapper_utilities.h" #include "processes/graph_coloring_process.h" @@ -51,8 +52,8 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Auxiliary functions for the MappingApplication in MPI +/** This class provides a set of auxiliary functions for MPI that are used by several other functions / classes */ class MapperUtilitiesMPI { @@ -206,7 +207,7 @@ class MapperUtilitiesMPI static void PrintGraph(GraphType& rGraph, int NumColors) { - std::cout << "\nCommunication Graph: " << std::endl; + std::cout << "Mapper Communication Graph: " << std::endl; std::cout << std::setw(5); for(std::size_t i = 0; i < rGraph.size1(); ++i) { @@ -219,63 +220,12 @@ class MapperUtilitiesMPI std::cout << std::endl; } - static void ComputeLocalBoundingBox(ModelPart& rModelPart, - double* pLocalBoundingBox) + static void PrintRankLocalBoundingBox(double* pBoundingBox, const int CommRank) { - // xmax, xmin, ymax, ymin, zmax, zmin - // loop over local nodes - for (auto &r_node : rModelPart.GetCommunicator().LocalMesh().Nodes()) - { - pLocalBoundingBox[0] = std::max(r_node.X(), pLocalBoundingBox[0]); - pLocalBoundingBox[1] = std::min(r_node.X(), pLocalBoundingBox[1]); - pLocalBoundingBox[2] = std::max(r_node.Y(), pLocalBoundingBox[2]); - pLocalBoundingBox[3] = std::min(r_node.Y(), pLocalBoundingBox[3]); - pLocalBoundingBox[4] = std::max(r_node.Z(), pLocalBoundingBox[4]); - pLocalBoundingBox[5] = std::min(r_node.Z(), pLocalBoundingBox[5]); - } - // loop over ghost nodes (necessary if conditions have only ghost nodes) - for (auto &r_node : rModelPart.GetCommunicator().GhostMesh().Nodes()) - { - pLocalBoundingBox[0] = std::max(r_node.X(), pLocalBoundingBox[0]); - pLocalBoundingBox[1] = std::min(r_node.X(), pLocalBoundingBox[1]); - pLocalBoundingBox[2] = std::max(r_node.Y(), pLocalBoundingBox[2]); - pLocalBoundingBox[3] = std::min(r_node.Y(), pLocalBoundingBox[3]); - pLocalBoundingBox[4] = std::max(r_node.Z(), pLocalBoundingBox[4]); - pLocalBoundingBox[5] = std::min(r_node.Z(), pLocalBoundingBox[5]); - } - } - - static void ComputeLocalBoundingBoxWithTolerance(double* pLocalBoundingBox, - const double Tolerance, - const int CommRank, - const int EchoLevel, - double* pLocalBoundingBoxWithTolerance) - { - // xmax, xmin, ymax, ymin, zmax, zmin - pLocalBoundingBoxWithTolerance[0] = pLocalBoundingBox[0] + Tolerance; - pLocalBoundingBoxWithTolerance[1] = pLocalBoundingBox[1] - Tolerance; - pLocalBoundingBoxWithTolerance[2] = pLocalBoundingBox[2] + Tolerance; - pLocalBoundingBoxWithTolerance[3] = pLocalBoundingBox[3] - Tolerance; - pLocalBoundingBoxWithTolerance[4] = pLocalBoundingBox[4] + Tolerance; - pLocalBoundingBoxWithTolerance[5] = pLocalBoundingBox[5] - Tolerance; - - if (EchoLevel > 3) - { - MapperUtilitiesMPI::PrintBoundingBox(pLocalBoundingBoxWithTolerance, CommRank); - } - } - - static void PrintBoundingBox(double* pBoundingBox, const int CommRank) - { - std::cout << "\nBounding Box, Rank " << CommRank << " [ " - << pBoundingBox[1] << " " // xmin - << pBoundingBox[3] << " " // ymin - << pBoundingBox[5] << " ] [ " // zmin - << pBoundingBox[0] << " " // xmax - << pBoundingBox[2] << " " // ymax - << pBoundingBox[4] << " ]" // zmax + std::cout << "Rank-local Bounding Box, Rank " << CommRank << ": " + << MapperUtilities::BoundingBoxStingStream(pBoundingBox) << std::endl; - // TODO maybe write it such that gid can directly read it (=> batch file?) + // TODO maybe write it such that gid can directly read it } static void ComputeGlobalBoundingBoxes(double* pLocalBoundingBox, @@ -285,11 +235,16 @@ class MapperUtilitiesMPI double* pGlobalBoundingBoxes) { double* local_bounding_box_tol = new double[6]; - MapperUtilitiesMPI::ComputeLocalBoundingBoxWithTolerance(pLocalBoundingBox, + MapperUtilities::ComputeBoundingBoxWithTolerance(pLocalBoundingBox, Tolerance, - CommRank, - EchoLevel, local_bounding_box_tol); + + if (EchoLevel >= 3) + { + MapperUtilitiesMPI::PrintRankLocalBoundingBox(local_bounding_box_tol, CommRank); + // TODO maybe write it such that gid can directly read it + } + MPI_Allgather(local_bounding_box_tol, 6, MPI_DOUBLE, pGlobalBoundingBoxes, 6, MPI_DOUBLE, MPI_COMM_WORLD); delete local_bounding_box_tol; diff --git a/applications/MappingApplication/custom_utilities/nearest_element_mapper.h b/applications/MappingApplication/custom_utilities/nearest_element_mapper.h index a533134e9592..b0900f149918 100644 --- a/applications/MappingApplication/custom_utilities/nearest_element_mapper.h +++ b/applications/MappingApplication/custom_utilities/nearest_element_mapper.h @@ -48,8 +48,14 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -/** Detail class definition. +/// Interpolative Mapper +/** This class implements the Nearest Element Mapping technique. +* Each node on the destination side gets assigned is's closest condition or element (distance to center) +* on the other side of the interface. +* In the mapping phase every node gets assigned the interpolated value of the condition/element. +* The interpolation is done with the shape funcitons +* For information abt the available echo_levels and the JSON default-parameters +* look into the class description of the MapperCommunicator */ class NearestElementMapper : public Mapper { @@ -64,9 +70,9 @@ class NearestElementMapper : public Mapper ///@name Life Cycle ///@{ - NearestElementMapper(ModelPart& i_model_part_origin, ModelPart& i_model_part_destination, - Parameters& rJsonParameters) : Mapper( - i_model_part_origin, i_model_part_destination, rJsonParameters) + NearestElementMapper(ModelPart& rModelPartOrigin, ModelPart& rModelPartDestination, + Parameters JsonParameters) : Mapper( + rModelPartOrigin, rModelPartDestination, JsonParameters) { mpMapperCommunicator->InitializeOrigin(MapperUtilities::Condition_Center); mpMapperCommunicator->InitializeDestination(MapperUtilities::Node_Coords); diff --git a/applications/MappingApplication/custom_utilities/nearest_neighbor_mapper.h b/applications/MappingApplication/custom_utilities/nearest_neighbor_mapper.h index 04178222b368..9978f5a77d72 100644 --- a/applications/MappingApplication/custom_utilities/nearest_neighbor_mapper.h +++ b/applications/MappingApplication/custom_utilities/nearest_neighbor_mapper.h @@ -45,7 +45,14 @@ namespace Kratos ///@} ///@name Kratos Classes ///@{ -/// Short class definition. + +/// Nearest Neighbor Mapper +/** This class implements the Nearest Neighbor Mapping technique. +* Each node on the destination side gets assigned is's closest neighbor on the other side of the interface. +* In the mapping phase every node gets assigned the value of it's neighbor +* For information abt the available echo_levels and the JSON default-parameters +* look into the class description of the MapperCommunicator +*/ class NearestNeighborMapper : public Mapper { @@ -63,9 +70,9 @@ class NearestNeighborMapper : public Mapper ///@name Life Cycle ///@{ - NearestNeighborMapper(ModelPart& i_model_part_origin, ModelPart& i_model_part_destination, - Parameters& rJsonParameters) : Mapper( - i_model_part_origin, i_model_part_destination, rJsonParameters) + NearestNeighborMapper(ModelPart& rModelPartOrigin, ModelPart& rModelPartDestination, + Parameters JsonParameters) : Mapper( + rModelPartOrigin, rModelPartDestination, JsonParameters) { mpMapperCommunicator->InitializeOrigin(MapperUtilities::Node_Coords); mpMapperCommunicator->InitializeDestination(MapperUtilities::Node_Coords); diff --git a/applications/MeshingApplication/CMakeLists.txt b/applications/MeshingApplication/CMakeLists.txt index f5d43abcd8bc..0e6097b42b96 100644 --- a/applications/MeshingApplication/CMakeLists.txt +++ b/applications/MeshingApplication/CMakeLists.txt @@ -29,15 +29,30 @@ add_subdirectory(${CMAKE_CURRENT_SOURCE_DIR}/custom_external_libraries/tetgen/te add_subdirectory(${CMAKE_CURRENT_SOURCE_DIR}/custom_external_libraries/tetMeshOpt) ## generate variables with the sources +if(${INCLUDE_MMG} MATCHES ON) set( KRATOS_MESHING_APPLICATION_SOURCES ${CMAKE_CURRENT_SOURCE_DIR}/meshing_application.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/kratos_meshing_python_application.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_meshers_to_python.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_processes_to_python.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_custom_utilities_to_python.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_custom_strategies_to_python.cpp ${CMAKE_CURRENT_SOURCE_DIR}/external_includes/mesh_suites.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_utilities/local_refine_geometry_mesh.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_processes/mmg_process.cpp ) +else(${INCLUDE_MMG} MATCHES ON) +set( KRATOS_MESHING_APPLICATION_SOURCES + ${CMAKE_CURRENT_SOURCE_DIR}/meshing_application.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/kratos_meshing_python_application.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_meshers_to_python.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_processes_to_python.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_custom_utilities_to_python.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_custom_strategies_to_python.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/external_includes/mesh_suites.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_utilities/local_refine_geometry_mesh.cpp +) +endif(${INCLUDE_MMG} MATCHES ON) ############################################################### ## define library Kratos which defines the basic python interface diff --git a/applications/MeshingApplication/custom_external_libraries/mmg/build/configure.sh b/applications/MeshingApplication/custom_external_libraries/mmg/build/configure.sh index a47cfdd9dcd5..6b1cc07f3a9e 100644 --- a/applications/MeshingApplication/custom_external_libraries/mmg/build/configure.sh +++ b/applications/MeshingApplication/custom_external_libraries/mmg/build/configure.sh @@ -6,7 +6,14 @@ cmake .. \ -DSCOTCHERR_LIBRARY="libscotcherr-5.1.so" \ -DCMAKE_CXX_FLAGS="-O3 -msse3 -fPIC -fopenmp" \ -DCMAKE_C_FLAGS="-O3 -msse3 -fPIC -fopenmp" \ - +-DLIBMMG_SHARED=ON \ +-DLIBMMG_STATIC=OFF \ +-DLIBMMGS_SHARED=ON \ +-DLIBMMGS_STATIC=OFF \ +-DLIBMMG2D_SHARED=ON \ +-DLIBMMG2D_STATIC=OFF \ +-DLIBMMG3D_SHARED=ON \ +-DLIBMMG3D_STATIC=OFF \ # If you ha modern processor use this instructions instead (look the whole list here https://software.intel.com/sites/landingpage/IntrinsicsGuide/) # With relatively new (Intel i7 2013 works with -maxvx) # -DCMAKE_CXX_FLAGS="-O3 -mavx2 -fPIC -fopenmp" \ diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.cpp index 9a1551d2c753..023415c15691 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.cpp @@ -11,12 +11,12 @@ bool TSurLoader:: save(const char* filename, TMesh* aMesh, int flags ) int i,nG; TTriangle *tr; - TStringList* st = new TStringList(); + auto st = new TStringList(); st->Add((char*)("*ELEMENT GROUPS")); - char* s = new char[120]; + auto s = new char[120]; - if (aMesh->patchList== NULL) + if (aMesh->patchList== nullptr) nG = 0 ; else nG = aMesh->patchList->Count(); @@ -73,7 +73,7 @@ bool TVMWLoader::save(const char* aMeshName, TMesh* aMesh, int flags ) m = (TVolumeMesh*)(aMesh); F = new TStringList(); F->Add((char*)("*COORDINATES")); - char* s = new char[120]; + auto s = new char[120]; sprintf(s, "%d", m->vertexes->Count()); F->Add(s); for (i=0; ivertexes->Count() ;i++) @@ -107,17 +107,17 @@ bool TVMWLoader::save(const char* aMeshName, TMesh* aMesh, int flags ) TMesh* TVMWLoader::load(const char* aMeshName) { FILE* fMesh; - TVolumeMesh* m = new TVolumeMesh(); - char *line = new char[200]; - char *line2 = new char[200]; + auto m = new TVolumeMesh(); + auto line = new char[200]; + auto line2 = new char[200]; int nCoords; size_t ctrlFlag ; fMesh = fopen( aMeshName,"rb"); //xx = rb, wb, read and write binary, more - if (fMesh==NULL) + if (fMesh==nullptr) { std::cout << "Invalid filename " << aMeshName; - return NULL; + return nullptr; } // obtain file size: fseek (fMesh , 0 , SEEK_END); @@ -131,7 +131,7 @@ TMesh* TVMWLoader::load(const char* aMeshName) // Read coords ctrlFlag = fscanf(fMesh, "%d", &nCoords); - if (ctrlFlag == 0) { std::cout << "Invalid read access " << aMeshName; return NULL; } + if (ctrlFlag == 0) { std::cout << "Invalid read access " << aMeshName; return nullptr; } for (int i=0; isetID( id ); m->addVertex(v); } @@ -159,38 +159,38 @@ TMesh* TVMWLoader::load(const char* aMeshName) //ctrlFlag =fread (line,17,1,fMesh); ctrlFlag = fscanf(fMesh, "%s%s", line,line2); - if (ctrlFlag == 0 ) { std::cout << "Invalid read access " << aMeshName; return NULL; } + if (ctrlFlag == 0 ) { std::cout << "Invalid read access " << aMeshName; return nullptr; } ctrlFlag = fscanf(fMesh, "%s", line); //if (ctrlFlag == 0 ) { std::cout << "Invalid read access " << aMeshName; return NULL; } ctrlFlag =fscanf(fMesh, "%d%d%s", &elGroups,&numElements,line); - if (ctrlFlag == 0 ) { std::cout << "Invalid read access " << aMeshName; return NULL; } + if (ctrlFlag == 0 ) { std::cout << "Invalid read access " << aMeshName; return nullptr; } ctrlFlag = fscanf(fMesh, "%s", line); - if (ctrlFlag == 0 ) { std::cout << "Invalid read access " << aMeshName; return NULL; } + if (ctrlFlag == 0 ) { std::cout << "Invalid read access " << aMeshName; return nullptr; } for (int i=0; ifindVertexById(iv0); TVertex* v1 = m->findVertexById(iv1); TVertex* v2 = m->findVertexById(iv2); TVertex* v3 = m->findVertexById(iv3); - TTetra* t = new TTetra(NULL, v0,v1,v2,v3); + auto t = new TTetra(nullptr, v0,v1,v2,v3); m->elements->Add(t); } fclose(fMesh); @@ -242,7 +242,7 @@ bool TElementTetraLoader::save(const char* aMeshName, TMesh* aMesh, int flags ) for (i = 0 ; ivertexes->Count() ; i++) { v = m->vertexes->elementAt(i); - if (v->elementsList == NULL) continue; + if (v->elementsList == nullptr) continue; s = intToStr(v->getID()); s = s + " "; @@ -314,7 +314,7 @@ bool TElementTetraLoader::save(const char* aMeshName, TMesh* aMesh, int flags ) s = intToString(m->vertexes->Count()); st->Add(s); - TList *lneigh = new TList(); + auto lneigh = new TList(); for (i=0 ; ivertexes->Count();i++) { @@ -349,9 +349,9 @@ bool TGIDLoad::save(const char* aMeshName, TMesh* aMesh, int flags ) TMesh* TGIDLoad::load(const char* aMeshName) { FILE* fMesh; - TVolumeMesh* m = new TVolumeMesh(); + auto m = new TVolumeMesh(); - TStringList* st = new TStringList(); + auto st = new TStringList(); st->loadFromFile(aMeshName); // Read coords @@ -364,7 +364,7 @@ TMesh* TGIDLoad::load(const char* aMeshName) float x = 0,y = 0,z = 0; std::string s = st->strings[i]; - TVertex* v = new TVertex(x,y,z); + auto v = new TVertex(x,y,z); v->setID( i ); m->addVertex(v); } diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.h b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.h index 08e527d5d292..84afa2ec1989 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.h +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.h @@ -41,10 +41,10 @@ private : char* fLastLoaded; public : TSurLoader(){ return; } - ~TSurLoader(){return; } - virtual bool save(const char* filename, TMesh* aMesh , int flags = 0); + ~TSurLoader() override{return; } + bool save(const char* filename, TMesh* aMesh , int flags = 0) override; - virtual TMesh* load(const char* aMeshName) + TMesh* load(const char* aMeshName) override { std :: cout << "Sur format Loader not implemented "<< "\n"; return nil; @@ -57,19 +57,19 @@ private : char* fLastLoaded; public : TVMWLoader(){ return; } - ~TVMWLoader(){return; } + ~TVMWLoader() override{return; } - virtual bool save(const char* aMeshName, TMesh* aMesh , int flags = 0); + bool save(const char* aMeshName, TMesh* aMesh , int flags = 0) override; - virtual TMesh* load(const char* aMeshName); + TMesh* load(const char* aMeshName) override; }; class TElementTetraLoader : public TMeshLoader { public : - virtual TMesh* load(const char* aMeshName){ return NULL;}; - virtual bool save(const char* aMeshName, TMesh* aMesh , int flags = 0); + TMesh* load(const char* aMeshName) override{ return nullptr;}; + bool save(const char* aMeshName, TMesh* aMesh , int flags = 0) override; }; @@ -79,11 +79,11 @@ private : char* fLastLoaded; public : TGIDLoad(){ return; } - ~TGIDLoad(){return; } + ~TGIDLoad() override{return; } - virtual bool save(const char* aMeshName, TMesh* aMesh , int flags = 0); + bool save(const char* aMeshName, TMesh* aMesh , int flags = 0) override; - virtual TMesh* load(const char* aMeshName); + TMesh* load(const char* aMeshName) override; }; diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.cpp index 620559c08124..5aa0fcf6147c 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.cpp @@ -178,7 +178,7 @@ void localMeshSmooth(int i, int thId ,TObject* destObject) TVertex *v = (TVertex*)destObject; if (v->fixed == 1) return; vList = v->elementsList; - if (vList == NULL) return ; + if (vList == nullptr) return ; if (vList->Count() == 0) return; //calculo la calidad minima del set minq = 1000000; diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.cpp index 76b1fed069a1..819f1119d040 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.cpp @@ -22,7 +22,7 @@ bool* _faces; int innerID = 0; int innerNumThreads =12; -TList * resultedClusters = NULL; +TList * resultedClusters = nullptr; void setNumThreads(int nt) { @@ -91,7 +91,7 @@ void parallelFor(int from, int to, TList* elements,TStForLoopElement void parallelFor(int from, int to, TList* elements,TStForLoopElement call) { - TList* lo = new TList(); + auto lo = new TList(); for (int i=0; iCount();i++) lo->Add(elements->structure[i]); @@ -119,7 +119,7 @@ void localProcessI(int i, int thId ,TObject* destObject) bool res; t = (TTetra*)( destObject); - if (t == NULL ) return ; + if (t == nullptr ) return ; for (j = 0 ; j<4; j++) { @@ -186,7 +186,7 @@ void fastGetSurfaceTriangles(TMesh* aMesh) { TTriangle *tr = (TTriangle*)(aMesh->fFaces->structure[i]); // Si tengo el pool activado, lo guardo ahi - if (aMesh->memPool == NULL ) + if (aMesh->memPool == nullptr ) delete tr; else aMesh->memPool->releaseInstance(tr); @@ -218,7 +218,7 @@ void fastGetSurfaceTriangles(TMesh* aMesh) v0 = t->vertexes[ TTetraFaces[j*3] ]; v1 = t->vertexes[ TTetraFaces[j*3+1] ]; v2 = t->vertexes[ TTetraFaces[j*3+2] ]; - if (aMesh->memPool == NULL ) + if (aMesh->memPool == nullptr ) tr = new TTriangle( v0,v1,v2); else tr = aMesh->memPool->getTriangleInstance(v0,v1,v2); @@ -264,8 +264,8 @@ void lpEvaluateClusterByFace(int i, int thId ,TObject* destObject) (vi->getID() < v2->getID()) ) { //Obtengo el Tetra vecino - t1 = t0->getTetraNeighbour(0,v0,v1,v2,NULL); - if (t1 == NULL ) continue; + t1 = t0->getTetraNeighbour(0,v0,v1,v2,nullptr); + if (t1 == nullptr ) continue; if (t1->fMinDiedralAngle>minExpectedAngle) continue; if (t0->getID()>t1->getID()) continue; // Evaluo @@ -293,14 +293,14 @@ void getElementsByEdgeFaster(TVertex *v0, TVertex*v1 , TList* inspecte int k; TVertex *nv0,*nv1,*nv2,*fv0,*fv1,*fv2; //--- Obtengo el primer elemento que tenga esta arista - ti = NULL; - t = NULL; + ti = nullptr; + t = nullptr; //Para el vertice 0 for (k = 0 ; kelementsList->Count() ; k++) { t = (TTetra*)(v0->elementsList->elementAt(k)); - if (t == NULL) continue; + if (t == nullptr) continue; if (t->isdestroyed) continue; if (!t->hasEdge(v0,v1)) continue; ti = t; @@ -330,7 +330,7 @@ void getElementsByEdgeFaster(TVertex *v0, TVertex*v1 , TList* inspecte //Di la vuelta if (tn == ti) {iface = iface+5; break;} //Es una cara de superficie - if (tn == NULL) break; + if (tn == nullptr) break; // Sigo iterando t = tn; inspectedElements->Add(t); @@ -372,7 +372,7 @@ double getElementsByEdge(TVertex *v0, TVertex*v1 , TList* inspectedEle for (k = 0 ; kelementsList->Count() ; k++) { t = (TTetra*)(v0->elementsList->elementAt(k)); - if (t == NULL) continue; + if (t == nullptr) continue; if (t->isdestroyed) continue; if (!t->hasEdge(v0,v1)) continue; minQ = Min( t->fMinDiedralAngle , minQ); @@ -385,7 +385,7 @@ double getElementsByEdge(TVertex *v0, TVertex*v1 , TList* inspectedEle void lpEvaluateClusterByEdge(int i, int thId ,TObject* destObject) { TElementsCluster* aCluster = (TElementsCluster*)destObject; - TList* vl = new TList(); + auto vl = new TList(); TVertex *v0,*v1; int j; @@ -398,7 +398,7 @@ void lpEvaluateClusterByEdge(int i, int thId ,TObject* destObject) { v1 = (TVertex*)(vl->elementAt(j)); //if (v0->id>=v1->id) continue; - if (v1->elementsList == NULL) continue; + if (v1->elementsList == nullptr) continue; //int innerFlag = rand(); aCluster->inspectedElements->Clear(); @@ -435,7 +435,7 @@ void lpMeshSmooth(int i, int thId ,TObject* destObject) TVertex *v = aCluster->inspVertex; if (v->fixed == 1) return; vList = v->elementsList; - if (vList == NULL) return ; + if (vList == nullptr) return ; if (vList->Count() == 0) return; //calculo la calidad minima del set minq = 1000000; @@ -561,7 +561,7 @@ void assignVertexesAvoidingVisited(TList *vs, TList *vRes ,i for (i = 0 ; iCount() ; i++) { TVertex *v = vs->elementAt(i); - if (v == NULL ) continue; + if (v == nullptr ) continue; // Ya fue visitado en una iteracion previa if (v->visited>0) continue; // Ya lo marco otro thread!! @@ -572,7 +572,7 @@ void assignVertexesAvoidingVisited(TList *vs, TList *vRes ,i lneigh->Clear(); v->getVertexNeighboursByElem(lneigh); //lneigh = v->neighV; - if (lneigh == NULL) continue; + if (lneigh == nullptr) continue; if (lneigh->Count() == 0 ) continue; wasVisited = false; @@ -580,7 +580,7 @@ void assignVertexesAvoidingVisited(TList *vs, TList *vRes ,i for (j = 0 ; jCount() ; j++) { TVertex* v2 = (TVertex*)(lneigh->elementAt(j)); - if (v2 == NULL ) continue; + if (v2 == nullptr ) continue; if (v2->flag == iter) { wasVisited = true; @@ -597,7 +597,7 @@ void assignVertexesAvoidingVisited(TList *vs, TList *vRes ,i for (j = 0 ; jCount() ; j++) { TVertex* v2 = (TVertex*)(lneigh->elementAt(j)); - if (v2 == NULL ) continue; + if (v2 == nullptr ) continue; v2->flag = iter; } @@ -610,7 +610,7 @@ void assignVertexesAvoidingVisited(TList *vs, TList *vRes ,i void lpComputeQuality(int i, int thId ,TObject* destObject) { TTetra *t = (TTetra*)(destObject); - if (t == NULL) return; + if (t == nullptr) return; t->calidad = vrelaxQuality(t->vertexes); t->fMinDiedralAngle = diedralAngle(t->vertexes); } @@ -618,11 +618,11 @@ void lpComputeQuality(int i, int thId ,TObject* destObject) void lpCalculateVertexVertexNeigh(int i, int thId ,TObject* destObject) { TVertex *v = (TVertex*)(destObject); - if (v == NULL) return ; - if ( v->neighV == NULL) + if (v == nullptr) return ; + if ( v->neighV == nullptr) v->neighV = new TList(); v->neighV->Clear(); - v->getVertexNeighboursByElem(NULL,1); + v->getVertexNeighboursByElem(nullptr,1); } double ParallelEvaluateCluster(TMesh *aMesh , TVertexesEvaluator fc, int mode, bool sort) @@ -639,13 +639,13 @@ double ParallelEvaluateCluster(TMesh *aMesh , TVertexesEvaluator fc, int mode, b // Initialize variables vRes = new TList(); - if (resultedClusters == NULL) + if (resultedClusters == nullptr) { std :: cout <<"*********** Creating clusters**************** \n"; resultedClusters = new TList(); for (i = 0 ; iAdd( (TObject*)(e)); } } @@ -803,7 +803,7 @@ void preparePool() resultedClusters = new TList(); for (int i = 0 ; iAdd( (TObject*)(e)); } @@ -813,13 +813,13 @@ void clearPool() for (int i = 0; ielementAt(i)); - resultedClusters->setElementAt(i, NULL); + resultedClusters->setElementAt(i, nullptr); delete resC ; } delete resultedClusters ; - resultedClusters = NULL; + resultedClusters = nullptr; } diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.cpp index e92a356cc667..43e73a7fb6c3 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.cpp @@ -41,9 +41,9 @@ void startTimers() void startProcess(char* procName) { if (!TimingIsActive ) return ; - if (processNames == NULL ) processNames = new TList(); + if (processNames == nullptr ) processNames = new TList(); TTimeSignal *newT = findProcess(procName); - if (newT == NULL) + if (newT == nullptr) { newT = new TTimeSignal(procName); processNames->Add(newT); @@ -54,18 +54,18 @@ void startProcess(char* procName) void endProcess(char* procName) { if (!TimingIsActive ) return ; - if (processNames == NULL ) return ; + if (processNames == nullptr ) return ; TTimeSignal *newT = findProcess(procName); - if (newT == NULL) return ; + if (newT == nullptr) return ; newT->endTime(); } double endProcessR(char* procName) { if (!TimingIsActive ) return 0; - if (processNames == NULL ) return 0; + if (processNames == nullptr ) return 0; TTimeSignal *newT = findProcess(procName); - if (newT == NULL) return 0; + if (newT == nullptr) return 0; newT->endTime(); return newT->elapsedTime(); } @@ -95,5 +95,5 @@ TTimeSignal* findProcess(char* procName) if ( str1.compare( str2) == 0) return t; } - return NULL; + return nullptr; } diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.cpp index a5ecb2f90fc2..74c803a299da 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.cpp @@ -44,7 +44,7 @@ void TetQuality::getQuality() for (int i=0 ; i< aMesh->elements->Count();i++) { TTetra* t = (TTetra*)(aMesh->elements->elementAt(i)); - if (t == NULL) + if (t == nullptr) continue; t->update(); this->fDieMax = Max(fDieMax,t->fMaxDiedralAngle); diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.cpp index 9c4b7a446ee2..24d00c0f1b8b 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.cpp @@ -43,7 +43,7 @@ f->numberofpolygons = 1; f->polygonlist = new tetgenio::polygon[f->numberofpolygons]; f->numberofholes = 0; - f->holelist = NULL; + f->holelist = nullptr; tetgenio::polygon* p = &f->polygonlist[0]; p->numberofvertices = 3; p->vertexlist = new int[p->numberofvertices]; @@ -58,7 +58,7 @@ //perform meshing with tetgen tetrahedralize(tetgen_options, &in, &out); - TVolumeMesh* outMesh = new TVolumeMesh(); + auto outMesh = new TVolumeMesh(); //generate nodes @@ -68,7 +68,7 @@ double x = out.pointlist[base]; double y = out.pointlist[base+1]; double z = out.pointlist[base+2]; - TVertex*v = new TVertex(x,y,z); + auto v = new TVertex(x,y,z); v->setID( i ); outMesh->vertexes->Add(v); } @@ -83,7 +83,7 @@ TVertex *v2 = outMesh->findVertexById( out.tetrahedronlist[base+2]); TVertex *v3 = outMesh->findVertexById( out.tetrahedronlist[base+3]); - t = new TTetra(NULL, v0,v1,v2,v3); + t = new TTetra(nullptr, v0,v1,v2,v3); outMesh->elements->Add(t); } diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.cpp index acb4e01d5379..e985c384ebe2 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.cpp @@ -9,7 +9,7 @@ void splitTetrain4(TTetra *t , TList* vs ,TList* ts) TVertex *v0,*v1,*v2,*v3; float4 fPos; fPos = (t->vertexes[0]->fPos + t->vertexes[1]->fPos + t->vertexes[2]->fPos + t->vertexes[3]->fPos)*0.25; - TVertex *v = new TVertex(fPos); + auto v = new TVertex(fPos); vs->Add(v); int i; @@ -20,7 +20,7 @@ void splitTetrain4(TTetra *t , TList* vs ,TList* ts) v1 = t->vertexes[ TTetraFaces[i*3+1] ]; v2 = t->vertexes[ TTetraFaces[i*3+2] ]; v3 = v; - TTetra *nt = new TTetra(NULL,v0,v1,v2,v3); + auto nt = new TTetra(nullptr,v0,v1,v2,v3); ts->Add(nt); } return ; @@ -29,8 +29,8 @@ void splitTetrain4(TTetra *t , TList* vs ,TList* ts) void splitMeshin4(TMesh* m) { //------------------------------- - TList* vs = new TList(); - TList* ts= new TList(); + auto vs = new TList(); + auto ts= new TList(); for (int i=0; ielements->Count() ; i++) { TTetra *t = (TTetra*)(m->elements->elementAt(i)); @@ -76,18 +76,18 @@ void igetSurfaceTriangles(TList *elements , TList *res, TLis for (i = 0 ;i< elements->Count(); i++) { TTetra* t = (TTetra*)(elements->elementAt(i)); - if (t==NULL) continue; + if (t==nullptr) continue; - tr = t->getSurfaceTriangle(false, _tempL,NULL); + tr = t->getSurfaceTriangle(false, _tempL,nullptr); - if (tr!=NULL) + if (tr!=nullptr) { for ( j = 0 ; jCount();j++) { TVertex* v =(TVertex*)(tr->elementAt(j)); res->Add(v); - if (surfVertexes!=NULL) + if (surfVertexes!=nullptr) { if (surfVertexes->indexOf(v)<0) surfVertexes->Add(v); @@ -109,7 +109,7 @@ bool innerGetElementsSurface(TList* elements,TList* surfaceT for (i = 0; iCount() ; i++) { t =(TTetra*)( elements->structure[i]); - if ( t == NULL) continue; + if ( t == nullptr) continue; for (j = 0 ;j<4 ;j++) { @@ -129,8 +129,8 @@ bool innerGetElementsSurface(TList* elements,TList* surfaceT } } if (faceVisited) continue; - TTetra *t2 = t->getTetraNeighbour(0,v0,v1,v2,NULL); - if ((t2 != NULL) && (elements->indexOf(t2)>=0)) continue; + TTetra *t2 = t->getTetraNeighbour(0,v0,v1,v2,nullptr); + if ((t2 != nullptr) && (elements->indexOf(t2)>=0)) continue; surfaceT->Add(v0); surfaceT->Add(v1); @@ -218,7 +218,7 @@ void TVolumeMesh::removeFreeVertexes() for (int i=0; iCount() ; i++) { if (vertexes->structure[i]->elementsList->Count() == 0) - vertexes->setElementAt(i,NULL); + vertexes->setElementAt(i,nullptr); } vertexes->Pack(); @@ -230,7 +230,7 @@ TMesh() elements = new TList(); elementsToAdd = new TList(); elementsToRemove= new TList(); - this->memPool = NULL; + this->memPool = nullptr; } TVolumeMesh::~TVolumeMesh() @@ -252,7 +252,7 @@ TVolumeMesh::~TVolumeMesh() } delete vertexes; - if (fFaces != NULL) + if (fFaces != nullptr) { for (int i=0 ; iCount() ; i++) { @@ -262,11 +262,11 @@ TVolumeMesh::~TVolumeMesh() fFaces->Clear(); delete fFaces; } - fFaces = NULL; - vertexes = NULL; - elements = NULL; - vertexesToRemove = NULL; - selectedElements = NULL; + fFaces = nullptr; + vertexes = nullptr; + elements = nullptr; + vertexesToRemove = nullptr; + selectedElements = nullptr; } void TVolumeMesh::updateIndexes(int flag ) { @@ -278,11 +278,11 @@ void TVolumeMesh::updateIndexes(int flag ) for (int i=0; i< numVertices; i++) { TVertex* v= vertexes->elementAt(i); - if (v==NULL) continue; + if (v==nullptr) continue; if ( (flag & KEEP_ORIG_IDS) == 0) v->setID( i ); fMassCenter = fMassCenter +v->fPos; - if (v->elementsList!=NULL) + if (v->elementsList!=nullptr) v->elementsList->Clear(); else v->elementsList = new TList(); @@ -292,14 +292,14 @@ void TVolumeMesh::updateIndexes(int flag ) for (int i=0 ; iCount(); i++) { TTetra* t = (TTetra*)this->elements->elementAt(i); - if (t == NULL ) continue; + if (t == nullptr ) continue; if ((flag & KEEP_ORIG_IDS) == 0) t->setID( i ); - for (int k=0;k<4;k++) + for (auto & vertexe : t->vertexes) { - if ( t->vertexes[k]->elementsList !=NULL) + if ( vertexe->elementsList !=nullptr) { - t->vertexes[k]->elementsList->Add(t); + vertexe->elementsList->Add(t); } } } @@ -362,7 +362,7 @@ void TVolumeMesh::updateRefs() TTetra* _nt = (TTetra*)(elements->elementAt(i)); if ( _nt->flag==2) { - elements->setElementAt(i,NULL); + elements->setElementAt(i,nullptr); //delete _nt; } } @@ -425,7 +425,7 @@ TTetra* TVolumeMesh::isPointInside( float4 pos ) if (t->isInside(pos)) return t; } - return NULL; + return nullptr; } void TVolumeMesh::validate(bool showMessages) @@ -505,7 +505,7 @@ void TVolumeMesh::getSurfaceTriangles() this->fFaces->Clear(); res = new TList(); - igetSurfaceTriangles(this->elements ,res,NULL); + igetSurfaceTriangles(this->elements ,res,nullptr); for (j = 0 ; jCount(); j=j+3) { t = new TTriangle( (TVertex*)res->elementAt(j), (TVertex*)res->elementAt(j+1), (TVertex*)res->elementAt(j+2)); @@ -523,7 +523,7 @@ bool swapVolumeMesh(TVolumeMesh* aMesh) TTriangle *tr1; TVertex *v0,* v1,*v2,*v3,*v4; // aMesh.updateIndexes(0); - v0 = v1 = v2 = v3 = v4 = NULL; + v0 = v1 = v2 = v3 = v4 = nullptr; l = new TList(); l2 = new TList(); // l2 := TList.create; @@ -565,18 +565,18 @@ bool swapVolumeMesh(TVolumeMesh* aMesh) if ((_t!=t0) && (_t->hasFace(v0,v1,v3))) { l2->Clear(); - _t->getSurfaceTriangle(false,l2,NULL); + _t->getSurfaceTriangle(false,l2,nullptr); if (l2->Count() == 0) continue; t1 = _t; break; } } //No encontro ningun elemento vecino - if (t0 == NULL) continue; - if (t1 == NULL) continue; - if (v3 == NULL) continue; + if (t0 == nullptr) continue; + if (t1 == nullptr) continue; + if (v3 == nullptr) continue; v4 = t1->oppositeVertex(v0,v1,v3); - if (v4 == NULL) continue; + if (v4 == nullptr) continue; // verifico si mejora if (swapTetra(v0,v1,v2,v3,v4) ) @@ -584,8 +584,8 @@ bool swapVolumeMesh(TVolumeMesh* aMesh) t0->removeVertexRef(); t1->removeVertexRef(); - t0->Create(NULL,v1,v2,v4,v3); - t1->Create(NULL,v0,v4,v2,v3); + t0->Create(nullptr,v1,v2,v4,v3); + t1->Create(nullptr,v0,v4,v2,v3); aMesh->selectedElements->Add(t0); aMesh->selectedElements->Add(t1); //break; diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.h b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.h index bd6504995c94..5ff39fa3238e 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.h +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.h @@ -8,11 +8,11 @@ public : int numVertices ; int numElements ; TVolumeMesh(); - ~TVolumeMesh(); + ~TVolumeMesh() override; void getSurfaceTriangles(); - void updateRefs(); + void updateRefs() override; void validate(bool showMessages); - void updateIndexes(int flag = 1); + void updateIndexes(int flag = 1) override; void removeFreeVertexes(); TTetra* isPointInside( float4 pos ); }; diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_Types.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_Types.cpp index 031e7e03951d..b5ac56bde9d2 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_Types.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_Types.cpp @@ -10,10 +10,10 @@ bool sortByQuality(TObject* i, TObject* j) return ((TValuedObject*)(i))->calidad< ((TValuedObject*)(j))->calidad ; } /// Class TValuedObject -TValuedObject::TValuedObject(void) +TValuedObject::TValuedObject() { blockID = false; }; -TValuedObject::~TValuedObject(void) -{ }; +TValuedObject::~TValuedObject() += default;; void TValuedObject::setID(int nid) { @@ -39,14 +39,14 @@ TVertex::TVertex(float x,float y, float z) fPos.x= x; fPos.y = y; fPos.z = z; neighTr = new TList(); elementsList = new TList(); - neighV = NULL; + neighV = nullptr; } TVertex::TVertex(float4 v) { fPos.x= v.x; fPos.y = v.y; fPos.z = v.z; neighTr = new TList(); - neighV = NULL; + neighV = nullptr; elementsList = new TList(); } @@ -71,11 +71,11 @@ TList* TVertex::getVertexNeighboursByTriangle(TList* toL , i { TList* storeList ; - if (toL != NULL) + if (toL != nullptr) storeList = toL; else { - if (neighV == NULL) + if (neighV == nullptr) neighV = new TList(); neighV->Clear(); storeList = neighV; @@ -83,11 +83,11 @@ TList* TVertex::getVertexNeighboursByTriangle(TList* toL , i for (int i=0;i< neighTr->Count() ; i++) { TTriangle *t = (TTriangle*)( neighTr->elementAt(i)); - for (int j= 0; j<3 ;j++) + for (auto & vertexe : t->vertexes) { - if (t->vertexes[j] == this) continue; - if (storeList->indexOf( t->vertexes[j])<0) - storeList->Add(t->vertexes[j]); + if (vertexe == this) continue; + if (storeList->indexOf( vertexe)<0) + storeList->Add(vertexe); } } @@ -101,9 +101,9 @@ TList *TVertex::getVertexNeighboursByElem(TList *toL ,int de TList *storeList ; - if (toL == NULL) + if (toL == nullptr) { - if (neighV == NULL) neighV = new TList(); + if (neighV == nullptr) neighV = new TList(); storeList = neighV; } else @@ -115,7 +115,7 @@ TList *TVertex::getVertexNeighboursByElem(TList *toL ,int de for (j = 0 ; jCount() ; j++) { TTetra *t = (TTetra*)(elementsList->elementAt(j)); - if (t == NULL ) continue; + if (t == nullptr ) continue; if (t->isdestroyed) continue; for (k = 0 ; k<4 ; k++) { @@ -149,15 +149,15 @@ void TTriangle::calcEdges() bool TTriangle::verticesEncomun(TTriangle* otherT,TVertex* &v1,TVertex* &v2) { int i,j; - v1=NULL; - v2=NULL; + v1=nullptr; + v2=nullptr; for (i=0;i<2;i++) for (j=0;j<2;j++) { if ( vertexes[i] == otherT->vertexes[i]) { - if (v1==NULL) + if (v1==nullptr) v1 = vertexes[i] ; else if (v1!=vertexes[i] ) @@ -165,12 +165,12 @@ bool TTriangle::verticesEncomun(TTriangle* otherT,TVertex* &v1,TVertex* &v2) } } - return ((v1!=NULL) && (v2!=NULL)); + return ((v1!=nullptr) && (v2!=nullptr)); } //Class TElement TElement::TElement() {} -TElement::~TElement() {} +TElement::~TElement() = default; TElement::TElement(TVertex v0,TVertex v1,TVertex v2,TVertex v3){}; BoundBox TElement::CalcBound() { @@ -181,7 +181,7 @@ BoundBox TElement::CalcBound() // Class TTetra void TTetra::update() { - if (this == NULL ) return; + if (this == nullptr ) return; CalcAng(vertexes[0]->fPos, vertexes[1]->fPos, vertexes[2]->fPos , vertexes[3]->fPos,&fMinDiedralAngle,&fFaceAngle,&fVolume, &fMaxDiedralAngle); //fVolume =tetraVolume( ; } @@ -251,8 +251,8 @@ void TTetra::Create(TObject* owner, TVertex* v0,TVertex* v1,TVertex* v2,TVertex* //this->rColor = Float4(1.0f); this->isdestroyed = false; this->initialized = false; - this->NeighBourByFace = NULL; - this->Neighbours = NULL; + this->NeighBourByFace = nullptr; + this->Neighbours = nullptr; vertexes[0] = v0; vertexes[1] = v1; vertexes[2] = v2; @@ -310,7 +310,7 @@ TTetra* TTetra::getTetraNeighbour(int faceI, TVertex* v0,TVertex* v1,TVertex* v2 if (t2->hasFace(v0,v1,v2)) { return t2; } } */ - return NULL; + return nullptr; } @@ -326,10 +326,10 @@ TList* TTetra::getSurfaceTriangle(bool bmpMode , TList* res, TList* result; - if (res !=NULL) + if (res !=nullptr) result =res; else - result = NULL ; + result = nullptr ; for ( i=0;i<4;i++) { @@ -352,9 +352,9 @@ TList* TTetra::getSurfaceTriangle(bool bmpMode , TList* res, v0 = vertexes[1]; v1 = vertexes[3]; v2 = vertexes[2]; } - if (getTetraNeighbour(i,v0,v1,v2,result)== NULL) + if (getTetraNeighbour(i,v0,v1,v2,result)== nullptr) { - if (result==NULL) + if (result==nullptr) result = new TList(); result->Add( v0); result->Add( v1); @@ -378,7 +378,7 @@ TVertex* TTetra::oppositeVertex(TVertex *v0,TVertex *v1,TVertex *v2) else if ((vertexes[1]!=v0) && (vertexes[1]!=v1) && (vertexes[1]!=v2)) return vertexes[1]; else if ((vertexes[2]!=v0) && (vertexes[2]!=v1) && (vertexes[2]!=v2)) return vertexes[2]; else if ((vertexes[3]!=v0) && (vertexes[3]!=v1) && (vertexes[3]!=v2)) return vertexes[3]; - else return NULL; + else return nullptr; } bool TTetra::hasEdge(TVertex *v0,TVertex *v1) { @@ -403,7 +403,7 @@ bool TTetra::hasFace(TTetra* t1 ) int TTetra::hasVertex(TTetra t1 ){ return 0;} bool TTetra::hasVertex(TVertex v0 ) { return 0;} -TTetra* TTetra::getTetraNeighbour(int faceI ,TVertex v0,TVertex v1,TVertex v2, TList *tl) { return NULL;} +TTetra* TTetra::getTetraNeighbour(int faceI ,TVertex v0,TVertex v1,TVertex v2, TList *tl) { return nullptr;} void TTetra::replaceTriangle(TTriangle oldTr,TTriangle newTr ) {} @@ -424,7 +424,7 @@ TList* TTetra::getNeighboursByFace(int depth ,TList* nFL, bo } else { - if (this->NeighBourByFace == NULL) NeighBourByFace = new TList(); + if (this->NeighBourByFace == nullptr) NeighBourByFace = new TList(); result = NeighBourByFace; } result->Clear(); @@ -436,7 +436,7 @@ TList* TTetra::getNeighboursByFace(int depth ,TList* nFL, bo for (j = 0 ; j< vertexes[i]->elementsList->Count() ; j++) { t2 = (TTetra*)(vertexes[i]->elementsList->elementAt(j)); - if (t2 == NULL) continue; + if (t2 == nullptr) continue; if (t2== this) continue; if (t2->isdestroyed) continue; @@ -450,23 +450,23 @@ TList* TTetra::getNeighboursByFace(int depth ,TList* nFL, bo return result; } -TList* TTetra::getNeighbours(int depth) {return NULL;} +TList* TTetra::getNeighbours(int depth) {return nullptr;} void TTetra::removeVertexRef() { clearVertexRef(); - for (int i=0 ; i<4 ; i++) - if (vertexes[i]->elementsList != NULL ) - vertexes[i]->elementsList->Pack(); + for (auto & vertexe : vertexes) + if (vertexe->elementsList != nullptr ) + vertexe->elementsList->Pack(); } void TTetra::updateVertexRef() { - for (int i = 0 ; i<4 ; i++) + for (auto & vertexe : vertexes) { - if (vertexes[i]->elementsList == NULL) - vertexes[i]->elementsList = new TList(); - if ( vertexes[i]->elementsList->indexOf(this)<0 ) - vertexes[i]->elementsList->Add(this); + if (vertexe->elementsList == nullptr) + vertexe->elementsList = new TList(); + if ( vertexe->elementsList->indexOf(this)<0 ) + vertexe->elementsList->Add(this); } } @@ -475,7 +475,7 @@ TTetra* TTetra::getNeighByFace(TVertex*v0, TVertex*v1,TVertex*v2) { int k; TTetra *t2; - if (this->NeighBourByFace != NULL) + if (this->NeighBourByFace != nullptr) { // Costo 3 for (k=0;kCount();k++) @@ -495,20 +495,20 @@ TTetra* TTetra::getNeighByFace(TVertex*v0, TVertex*v1,TVertex*v2) if (t2->hasFace(v0,v1,v2)) return t2; } } - return NULL; + return nullptr; } void TTetra::clearVertexRef() { - for (int i=0; i<4 ; i++) + for (auto & vertexe : vertexes) { - if (vertexes[i]->elementsList != NULL) + if (vertexe->elementsList != nullptr) { - TList* _lv = vertexes[i]->elementsList; + TList* _lv = vertexe->elementsList; for (int j = 0 ; j<_lv->Count() ; j++) { if (_lv->elementAt(j) == this) - _lv->setElementAt(j,NULL); + _lv->setElementAt(j,nullptr); } } } @@ -534,7 +534,7 @@ TElementsPool::~TElementsPool() TTetra* TElementsPool::getTetraInstance() { if (availableElements->Count() == 0) - return new TTetra(NULL); + return new TTetra(nullptr); else { TTetra *t = availableElements->structure.back(); @@ -546,7 +546,7 @@ TTetra* TElementsPool::getTetraInstance() TTetra* TElementsPool::getTetraInstance(TVertex *v0,TVertex *v1,TVertex *v2,TVertex *v3) { if (availableElements->Count() == 0) - return new TTetra(NULL,v0,v1,v2,v3); + return new TTetra(nullptr,v0,v1,v2,v3); else { TTetra *t = availableElements->structure.back(); diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_Types.h b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_Types.h index ca29cc0d348e..fccac379f899 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_Types.h +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_Types.h @@ -72,12 +72,12 @@ class TVertex: public TNeighboured TVertex(float x,float y, float z); TVertex(float4 v); - ~TVertex(); + ~TVertex() override; void calcNormal(); float4 pos(); - TList *getVertexNeighboursByElem(TList *toL = NULL , int depth = 1, int avoidLowerIds = false); + TList *getVertexNeighboursByElem(TList *toL = nullptr , int depth = 1, int avoidLowerIds = false); - TList* getVertexNeighboursByTriangle(TList* toL = NULL , int depth = 1); + TList* getVertexNeighboursByTriangle(TList* toL = nullptr , int depth = 1); }; class TVertex3D : public TVertex @@ -120,7 +120,7 @@ class TElement : public TNeighboured TElement(); TElement(TVertex v0,TVertex v1,TVertex v2,TVertex v3); virtual BoundBox CalcBound() ; - virtual ~TElement(); + ~TElement() override; }; @@ -153,7 +153,7 @@ public : TTetra(TObject* owner, TVertex* v0,TVertex* v1,TVertex* v2,TVertex* v3, bool publish = true) ; - ~TTetra() ; + ~TTetra() override ; // Obtener el vecino que comparte estos 3 vertices TTetra* getTetraNeighbour(int faceI, TVertex* v0,TVertex* v1,TVertex* v2, TList* tl); @@ -180,7 +180,7 @@ public : bool isInvalid() ; - TList* getNeighboursByFace(int depth ,TList* nFL= NULL , bool ommitLowerIds = false) ; + TList* getNeighboursByFace(int depth ,TList* nFL= nullptr , bool ommitLowerIds = false) ; TTetra* getNeighByFace(TVertex*v0, TVertex*v1,TVertex*v2); TList* getNeighbours(int depth) ; @@ -247,7 +247,7 @@ class TMesh TMesh(void) { - patchList = NULL; + patchList = nullptr; selectedElements = new TList(); vertexes = new TList(); fFaces = new TList(); @@ -307,18 +307,18 @@ class TMesh // test if array is empty if (imax < imin) // set is empty, so return value showing not found - return NULL; + return nullptr; else { // calculate midpoint to cut set in half int imid = (imin + imax) / 2; if (imid>= vertexes->Count() ) - return NULL; + return nullptr; TVertex * v = vertexes->elementAt(imid); - if (v == NULL ) - return NULL; + if (v == nullptr ) + return nullptr; // three-way comparison if (v->getID() > key) diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.cpp index cdfce0d4bc76..9976017005dc 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.cpp @@ -39,7 +39,7 @@ std::string floatToString(float number) char* intToStr(int i) { - char* result = new char[100]; + auto result = new char[100]; sprintf( result, "%d", i ); return result ; } @@ -52,7 +52,7 @@ char* intToStr(int i, char* result) char* floatToStr(float f) { - char* result = new char[100]; + auto result = new char[100]; sprintf( result, "%f", f ); return result ; } diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.h b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.h index 42692a314b69..2ddabf796169 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.h +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.h @@ -66,10 +66,10 @@ public : for (int i=0; i<=lIndex ; i++) { - if (structure[i] != NULL ) continue; + if (structure[i] != nullptr ) continue; int nextNotNull = -1; for (int j=i+1 ; j<=lIndex ; j++) - if (structure[j] != NULL) + if (structure[j] != nullptr) { nextNotNull = j; break; @@ -77,13 +77,13 @@ public : if (nextNotNull >0) { structure[i] = structure[nextNotNull] ; - structure[nextNotNull] = NULL; + structure[nextNotNull] = nullptr; } } int lastIndex = 0; for ( lastIndex=0; lastIndex<=lIndex ; lastIndex++) { - if (structure[lastIndex] == NULL) + if (structure[lastIndex] == nullptr) break; } structure.resize(lastIndex); @@ -94,7 +94,7 @@ public : if (structure.size() == 0) return; if (structure.size() == 1) { - if (structure[0] == NULL) + if (structure[0] == nullptr) structure.resize(0); return ; } @@ -102,17 +102,17 @@ public : return PackKeepingOrder(); int sSize = structure.size(); int lastIndex =sSize-1; - while ((lastIndex>0) &&(structure[lastIndex] == NULL) ) lastIndex--; + while ((lastIndex>0) &&(structure[lastIndex] == nullptr) ) lastIndex--; int lIndex = lastIndex; for (int i=0; i<=lIndex ; i++) { if (i>=lastIndex) break; - if (structure[i] == NULL) + if (structure[i] == nullptr) { structure[i] = structure[lastIndex] ; - structure[lastIndex] = NULL; - while ((lastIndex>=i) &&(structure[lastIndex] == NULL) ) lastIndex--; + structure[lastIndex] = nullptr; + while ((lastIndex>=i) &&(structure[lastIndex] == nullptr) ) lastIndex--; } } @@ -122,7 +122,7 @@ public : int Count() { return structure.size(); } void Add(T elem) { - if ((ommitNULLSwhenAdd) && (elem == NULL)) + if ((ommitNULLSwhenAdd) && (elem == nullptr)) return ; structure.push_back(elem); } @@ -257,10 +257,9 @@ public : { FILE* fMesh; fMesh = fopen(filename,"wb"); //xx = rb, wb, read and write binary, more - for (unsigned int i=0; i* orig , TList* res , TListCount() ; i++) { t = (TTetra*)(orig->elementAt(i)); - if (t == NULL) continue; + if (t == nullptr) continue; - tr = t->getSurfaceTriangle(false, tempL,NULL); - if (tr!=NULL) + tr = t->getSurfaceTriangle(false, tempL,nullptr); + if (tr!=nullptr) { for (j = 0 ;jCount() ; j++) { @@ -80,10 +80,10 @@ double evaluteVertexChange(TVertex * vOrig , TVertex* vNew , // Si es invalido, lo borro if (cnt>1) { - velList->setElementAt(4*i, NULL); - velList->setElementAt(4*i+1, NULL); - velList->setElementAt(4*i+2, NULL); - velList->setElementAt(4*i+3, NULL); + velList->setElementAt(4*i, nullptr); + velList->setElementAt(4*i+1, nullptr); + velList->setElementAt(4*i+2, nullptr); + velList->setElementAt(4*i+3, nullptr); } } // elimino invalidos @@ -175,7 +175,7 @@ void innercollapseEdges(TVolumeMesh* aMesh , int maxSteps, if (vNew->flag >0) continue; if (vNew->isdestroyed) continue; if (vNew->getID()getID())continue; - if (vNew->elementsList == NULL) continue; + if (vNew->elementsList == nullptr) continue; // Reemplazo un vertice por otro que tambien cumpla las mismas propiedades if (vNew->isSurface && !vOrig->isSurface) continue; if (!vNew->isSurface && vOrig->isSurface) continue; @@ -237,7 +237,7 @@ TElementsCluster::TElementsCluster(TMesh* aMesh, TVertexesEvaluator functor ) tempL = new TList(); fc = functor; - vC =NULL; + vC =nullptr; //avgEdgeLength = aMesh.AvgEdgeLength; }; @@ -274,8 +274,8 @@ double TElementsCluster::getMinAngle() TElementsCluster::~TElementsCluster() { - fc =NULL; - vC =NULL; + fc =nullptr; + vC =nullptr; delete( goodTetraList); delete( surfaceT); delete( vertexes); @@ -300,7 +300,7 @@ int TElementsCluster::evaluateSet() TVertex *v0,*v1,*v2,*v3; float4 cn ; - vC = NULL; + vC = nullptr; if (testCenter) { @@ -388,7 +388,7 @@ void TElementsCluster::genElements(bool vertexIsNew) int i ; - if ((!testCenter) && (vC != NULL)) + if ((!testCenter) && (vC != nullptr)) delete vC; if (newElements->Count()>0) @@ -448,7 +448,7 @@ bool TElementsCluster::updateMesh(bool checkIfInvalid ) v2 = (TVertex*)(goodTetraList->elementAt(i+2)); v3 = (TVertex*)(goodTetraList->elementAt(i+3)); - t = new TTetra(NULL,v0,v1,v2,v3,true); + t = new TTetra(nullptr,v0,v1,v2,v3,true); newElements->Add(t); } @@ -474,10 +474,10 @@ bool TElementsCluster::updateMesh(bool checkIfInvalid ) for (i = 0 ; iCount();i++) { TTetra *_t = (TTetra *)(newElements->elementAt(i)); - if (_t != NULL) + if (_t != nullptr) { _t->removeVertexRef(); - newElements->setElementAt(i,NULL); + newElements->setElementAt(i,nullptr); delete _t; } } @@ -490,10 +490,10 @@ bool TElementsCluster::updateMesh(bool checkIfInvalid ) _t->isdestroyed = false; _t->updateVertexRef(); } - if (vC!= NULL) + if (vC!= nullptr) { delete vC; - vC = NULL; + vC = nullptr; } newElements->Clear(); copyEL->Clear(); @@ -526,12 +526,12 @@ bool TElementsCluster::generateSubMesh(double minExpectedQuality , double minExp tempTetraList->Clear(); goodTetraList->Clear(); tempL->Clear(); - vC = NULL; + vC = nullptr; for (i = 0 ; i< inspectedElements->Count() ; i++) { TTetra* _t = (TTetra*)( inspectedElements->elementAt(i)); - if (_t == NULL) continue; + if (_t == nullptr) continue; if (! _t->isdestroyed ) elements->Add(_t); } @@ -542,7 +542,7 @@ bool TElementsCluster::generateSubMesh(double minExpectedQuality , double minExp for (i = 0 ; i< elements->Count() ;i++) { TTetra* _t =t = (TTetra*)( elements->elementAt(i)); - if (_t == NULL) continue; + if (_t == nullptr) continue; _t->calidad = fc(_t->vertexes); _t->fMinDiedralAngle = diedralAngle(_t->vertexes); minQuality = Min(minQuality,_t->calidad ); @@ -587,7 +587,7 @@ void evaluateClusterByFace(TMesh *aMesh , double minExpectedQuality,TVertexesEva for (iv = 0 ; ivCount() ; iv++) { TTetra *_t = (TTetra*)(elements->elementAt(iv)); - if (_t == NULL ) continue; + if (_t == nullptr ) continue; if (_t->isdestroyed) continue; nFaces->Clear(); _t->getNeighboursByFace(1,nFaces); @@ -597,7 +597,7 @@ void evaluateClusterByFace(TMesh *aMesh , double minExpectedQuality,TVertexesEva for (j = 0 ; jCount() ; j++) { TTetra *_t2 = (TTetra*)(nFaces->elementAt(j)); - if (_t2 == NULL) continue; + if (_t2 == nullptr) continue; if (_t2->isdestroyed) continue; inspectedElements->Clear(); @@ -660,7 +660,7 @@ void evaluateClusterByNode(TMesh *aMesh , double minExpectedQuality,TVertexesEva for (i = 0 ;i< aMesh->elements->Count(); i++) { TTetra *t = (TTetra*)(aMesh->elements->elementAt(i)); - if (t==NULL) continue; + if (t==nullptr) continue; t->calidad =vrelaxQuality( t->vertexes); meshMinQ = Min(meshMinQ, t->calidad); } @@ -682,7 +682,7 @@ void evaluateClusterByNode(TMesh *aMesh , double minExpectedQuality,TVertexesEva for (iv = 0 ; ivCount() ; iv++) { inspVertex =(TVertex*)(vertexesCopy->elementAt(iv)); - if (inspVertex->elementsList== NULL) continue; + if (inspVertex->elementsList== nullptr) continue; inspVertex->elementsList->Pack(); if (inspVertex->elementsList->Count() == 0) continue; //--Limpio las variables @@ -756,7 +756,7 @@ void evaluateClusterByEdge(TMesh *aMesh , double minExpectedQuality,TVertexesEva vl->Clear(); v0->getVertexNeighboursByElem(vl,1,true); - if (vl == NULL) continue; + if (vl == nullptr) continue; if (vl->Count() == 0 ) continue; // Recorro los vertices vecinos @@ -764,14 +764,14 @@ void evaluateClusterByEdge(TMesh *aMesh , double minExpectedQuality,TVertexesEva { v1 = (TVertex*)(vl->elementAt(j)); if (v0->getID()>=v1->getID()) continue; - if (v1->elementsList == NULL) continue; + if (v1->elementsList == nullptr) continue; inspElements->Clear(); //--- Veo los vecinos de arista de ambos vertices //Para el vertice 0 for (k = 0 ; kelementsList->Count() ; k++) { t = (TTetra*)(v0->elementsList->elementAt(k)); - if (t == NULL) continue; + if (t == nullptr) continue; if (t->isdestroyed) continue; if (!t->hasEdge(v0,v1)) continue; if (t->innerFlag == i*1000+j) continue; @@ -782,7 +782,7 @@ void evaluateClusterByEdge(TMesh *aMesh , double minExpectedQuality,TVertexesEva for (k = 0 ; kelementsList->Count() ; k++) { t = (TTetra*)(v1->elementsList->elementAt(k)); - if (t == NULL) continue; + if (t == nullptr) continue; if (t->isdestroyed) continue; if (!t->hasEdge(v0,v1)) continue; if (t->innerFlag == i*1000+j) continue; @@ -901,7 +901,7 @@ double testTetraSplit4(TTetra *t, TVertex* v, TList* lRes , TVertexesE vs[2] = t->vertexes[ TTetraFaces[i*3+2] ]; vs[3] = v; q = Min(q , qualityFunction(vs) ); - if (lRes != NULL ) + if (lRes != nullptr ) { lRes->Add(vs[0]); lRes->Add(vs[1]); @@ -938,7 +938,7 @@ int vertexTetraReInsertion(TMesh *am ,TList* vertexesList ) v = (TVertex*)(vertexesList->elementAt(i)); t = aMesh->isPointInside(v->fPos); // Ningun tetra lo contiene - if (t == NULL) continue; + if (t == nullptr) continue; oldQ = minMeshQ; lRes->Clear(); @@ -949,13 +949,13 @@ int vertexTetraReInsertion(TMesh *am ,TList* vertexesList ) if (newQ>=oldQ) { //Pude volver a insertar el nodo - vertexesList->setElementAt(i, NULL); + vertexesList->setElementAt(i, nullptr); res ++ ; // Create new Tetra!! for (j = 0 ; jCount();j=j+4) { - tNew = new TTetra(NULL, (TVertex*)(lRes->structure[j]), + tNew = new TTetra(nullptr, (TVertex*)(lRes->structure[j]), (TVertex*)(lRes->structure[j+1]), (TVertex*)(lRes->structure[j+2]), (TVertex*)(lRes->structure[j+3])); diff --git a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.cpp b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.cpp index 3456def66ae5..4aeb4c45cbbb 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.cpp +++ b/applications/MeshingApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.cpp @@ -251,7 +251,7 @@ double vrelaxQuality(TVertex* vertexes[]) float relaxQuality(TObject* o) { - if ( (TTetra*)o != NULL) + if ( (TTetra*)o != nullptr) { TTetra* t = (TTetra*)(o); return (float)vrelaxQuality( t->vertexes ); @@ -328,10 +328,10 @@ double minDiedralAngle(float4 v0, float4 v1, float4 v2, float4 v3) double mD = 500000; - for (int i=0;i <6 ; i++) + for (double & i : d) { - d[i] =-acos(d[i]); - if (d[i] mD) mD = d[i]; + i =-acos(i); + if (i >mD) mD = i; } return (PI+mD)*180/PI; } diff --git a/applications/MeshingApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.cxx b/applications/MeshingApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.cxx index 6d0a74065be7..a24da0166a59 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.cxx +++ b/applications/MeshingApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.cxx @@ -61,18 +61,18 @@ bool tetgenio::load_node_call(FILE* infile, int markers, char* infilename) // Initialize 'pointlist', 'pointattributelist', and 'pointmarkerlist'. pointlist = new REAL[numberofpoints * 3]; - if (pointlist == (REAL *) NULL) { + if (pointlist == (REAL *) nullptr) { terminatetetgen(1); } if (numberofpointattributes > 0) { pointattributelist = new REAL[numberofpoints * numberofpointattributes]; - if (pointattributelist == (REAL *) NULL) { + if (pointattributelist == (REAL *) nullptr) { terminatetetgen(1); } } if (markers) { pointmarkerlist = new int[numberofpoints]; - if (pointmarkerlist == (int *) NULL) { + if (pointmarkerlist == (int *) nullptr) { terminatetetgen(1); } } @@ -139,14 +139,14 @@ bool tetgenio::load_node_call(FILE* infile, int markers, char* infilename) if (i < numberofpoints) { // Failed to read points due to some error. delete [] pointlist; - pointlist = (REAL *) NULL; + pointlist = (REAL *) nullptr; if (markers) { delete [] pointmarkerlist; - pointmarkerlist = (int *) NULL; + pointmarkerlist = (int *) nullptr; } if (numberofpointattributes > 0) { delete [] pointattributelist; - pointattributelist = (REAL *) NULL; + pointattributelist = (REAL *) nullptr; } numberofpoints = 0; return false; @@ -175,7 +175,7 @@ bool tetgenio::load_node(char* filebasename) // Try to open a .node file. infile = fopen(innodefilename, "r"); - if (infile == (FILE *) NULL) { + if (infile == (FILE *) nullptr) { printf("File I/O Error: Cannot access file %s.\n", innodefilename); return false; } @@ -184,7 +184,7 @@ bool tetgenio::load_node(char* filebasename) stringptr = readnumberline(inputline, infile, innodefilename); // Does this file contain an index colume? stringptr = strstr(inputline, "rbox"); - if (stringptr == NULL) { + if (stringptr == nullptr) { // Read number of points, number of dimensions, number of point // attributes, and number of boundary markers. stringptr = inputline; @@ -246,7 +246,7 @@ bool tetgenio::load_var(char* filebasename) strcpy(varfilename, filebasename); strcat(varfilename, ".var"); infile = fopen(varfilename, "r"); - if (infile != (FILE *) NULL) { + if (infile != (FILE *) nullptr) { printf("Opening %s.\n", varfilename); } else { // No such file. Ignore it without a message. @@ -358,7 +358,7 @@ bool tetgenio::load_mtr(char* filebasename) strcpy(mtrfilename, filebasename); strcat(mtrfilename, ".mtr"); infile = fopen(mtrfilename, "r"); - if (infile != (FILE *) NULL) { + if (infile != (FILE *) nullptr) { printf("Opening %s.\n", mtrfilename); } else { // No such file. Return. @@ -378,7 +378,7 @@ bool tetgenio::load_mtr(char* filebasename) // Allocate space for pointmtrlist. pointmtrlist = new REAL[numberofpoints * numberofpointmtrs]; - if (pointmtrlist == (REAL *) NULL) { + if (pointmtrlist == (REAL *) nullptr) { terminatetetgen(1); } mtrindex = 0; @@ -431,10 +431,10 @@ bool tetgenio::load_poly(char* filebasename) smesh = 0; // Try to open a .poly file. polyfile = fopen(inpolyfilename, "r"); - if (polyfile == (FILE *) NULL) { + if (polyfile == (FILE *) nullptr) { // .poly doesn't exist! Try to open a .smesh file. polyfile = fopen(insmeshfilename, "r"); - if (polyfile == (FILE *) NULL) { + if (polyfile == (FILE *) nullptr) { printf("File I/O Error: Cannot access file %s and %s.\n", inpolyfilename, insmeshfilename); return false; @@ -484,7 +484,7 @@ bool tetgenio::load_poly(char* filebasename) // Read the points from the .node file. printf("Opening %s.\n", innodefilename); infile = fopen(innodefilename, "r"); - if (infile == (FILE *) NULL) { + if (infile == (FILE *) nullptr) { printf("File I/O Error: Cannot access file %s.\n", innodefilename); return false; } @@ -763,8 +763,8 @@ bool tetgenio::load_poly(char* filebasename) // Read the region section. The 'region' section is optional, if we // don't reach the end-of-file, try read it in. - stringptr = readnumberline(inputline, polyfile, NULL); - if (stringptr != (char *) NULL && *stringptr != '\0') { + stringptr = readnumberline(inputline, polyfile, nullptr); + if (stringptr != (char *) nullptr && *stringptr != '\0') { numberofregions = (int) strtol (stringptr, &stringptr, 0); } else { numberofregions = 0; @@ -826,7 +826,7 @@ bool tetgenio::load_poly(char* filebasename) numberoffacets = 1; // Initialize the 'facetlist'. facetlist = new facet[numberoffacets]; - facetmarkerlist = (int *) NULL; // No facet markers. + facetmarkerlist = (int *) nullptr; // No facet markers. f = &(facetlist[0]); init(f); // Read number of segments. @@ -925,12 +925,12 @@ bool tetgenio::load_off(char* filebasename) // OFF requires the index starts from '0'. firstnumber = 0; - while ((bufferp = readline(buffer, fp, &line_count)) != NULL) { + while ((bufferp = readline(buffer, fp, &line_count)) != nullptr) { // Check section if (nverts == 0) { // Read header bufferp = strstr(bufferp, "OFF"); - if (bufferp != NULL) { + if (bufferp != nullptr) { // Read mesh counts bufferp = findnextnumber(bufferp); // Skip field "OFF". if (*bufferp == '\0') { @@ -1073,7 +1073,7 @@ bool tetgenio::load_ply(char* filebasename) // PLY requires the index starts from '0'. firstnumber = 0; - while ((bufferp = readline(buffer, fp, &line_count)) != NULL) { + while ((bufferp = readline(buffer, fp, &line_count)) != nullptr) { if (!endheader) { // Find if it is the keyword "end_header". str = strstr(bufferp, "end_header"); @@ -1278,15 +1278,15 @@ bool tetgenio::load_stl(char* filebasename) printf("Opening %s.\n", infilename); // STL file has no number of points available. Use a list to read points. - plist = new tetgenmesh::list(sizeof(double) * 3, NULL, 1024); + plist = new tetgenmesh::list(sizeof(double) * 3, nullptr, 1024); - while ((bufferp = readline(buffer, fp, &line_count)) != NULL) { + while ((bufferp = readline(buffer, fp, &line_count)) != nullptr) { // The ASCII .stl file must start with the lower case keyword solid and // end with endsolid. if (solid == 0) { // Read header bufferp = strstr(bufferp, "solid"); - if (bufferp != NULL) { + if (bufferp != nullptr) { solid = 1; } } else { @@ -1294,14 +1294,14 @@ bool tetgenio::load_stl(char* filebasename) str = bufferp; // Is this the end of the solid. bufferp = strstr(bufferp, "endsolid"); - if (bufferp != NULL) { + if (bufferp != nullptr) { solid = 0; } else { // Read the XYZ coordinates if it is a vertex. bufferp = str; bufferp = strstr(bufferp, "vertex"); - if (bufferp != NULL) { - coord = (double *) plist->append(NULL); + if (bufferp != nullptr) { + coord = (double *) plist->append(nullptr); for (i = 0; i < 3; i++) { bufferp = findnextnumber(bufferp); if (*bufferp == '\0') { @@ -1412,7 +1412,7 @@ bool tetgenio::load_medit(char* filebasename) // Default uses the index starts from '1'. firstnumber = 1; - while ((bufferp = readline(buffer, fp, &line_count)) != NULL) { + while ((bufferp = readline(buffer, fp, &line_count)) != nullptr) { if (*bufferp == '#') continue; // A comment line is skipped. if (dimension == 0) { // Find if it is the keyword "Dimension". @@ -1457,7 +1457,7 @@ bool tetgenio::load_medit(char* filebasename) // Read the follwoing node list. for (i = 0; i < nverts; i++) { bufferp = readline(buffer, fp, &line_count); - if (bufferp == NULL) { + if (bufferp == nullptr) { printf("Unexpected end of file on line %d in file %s\n", line_count, infilename); fclose(fp); @@ -1536,7 +1536,7 @@ bool tetgenio::load_medit(char* filebasename) // Read the following list of faces. for (i = numberoffacets; i < numberoffacets + nfaces; i++) { bufferp = readline(buffer, fp, &line_count); - if (bufferp == NULL) { + if (bufferp == nullptr) { printf("Unexpected end of file on line %d in file %s\n", line_count, infilename); fclose(fp); @@ -1639,7 +1639,7 @@ bool tetgenio::load_vtk(char* filebasename) firstnumber = 0; strcpy(mode, "BINARY"); - while((bufferp = readline(line, fp, &line_count)) != NULL) { + while((bufferp = readline(line, fp, &line_count)) != nullptr) { if(strlen(line) == 0) continue; //swallow lines beginning with a comment sign or white space if(line[0] == '#' || line[0]=='\n' || line[0] == 10 || line[0] == 13 || @@ -1689,7 +1689,7 @@ bool tetgenio::load_vtk(char* filebasename) } else if(!strcmp(mode, "ASCII")) { for(i = 0; i < nverts; i++){ bufferp = readline(line, fp, &line_count); - if (bufferp == NULL) { + if (bufferp == nullptr) { printf("Unexpected end of file on line %d in file %s\n", line_count, infilename); fclose(fp); @@ -1882,7 +1882,7 @@ bool tetgenio::load_tetmesh(char* filebasename) infilename = innodefilename; printf("Opening %s.\n", infilename); infile = fopen(infilename, "r"); - if (infile == (FILE *) NULL) { + if (infile == (FILE *) nullptr) { printf("File I/O Error: Cannot access file %s.\n", infilename); return false; } @@ -1890,7 +1890,7 @@ bool tetgenio::load_tetmesh(char* filebasename) stringptr = readnumberline(inputline, infile, infilename); // Is this list of points generated from rbox? stringptr = strstr(inputline, "rbox"); - if (stringptr == NULL) { + if (stringptr == nullptr) { // Read number of points, number of dimensions, number of point // attributes, and number of boundary markers. stringptr = inputline; @@ -1936,7 +1936,7 @@ bool tetgenio::load_tetmesh(char* filebasename) if (mesh_dim == 3) { infilename = inelefilename; infile = fopen(infilename, "r"); - if (infile != (FILE *) NULL) { + if (infile != (FILE *) nullptr) { printf("Opening %s.\n", infilename); // Read number of elements, number of corners (4 or 10), number of // element attributes. @@ -1963,14 +1963,14 @@ bool tetgenio::load_tetmesh(char* filebasename) // Allocate memory for tetrahedra. if (numberoftetrahedra > 0) { tetrahedronlist = new int[numberoftetrahedra * numberofcorners]; - if (tetrahedronlist == (int *) NULL) { + if (tetrahedronlist == (int *) nullptr) { terminatetetgen(1); } // Allocate memory for output tetrahedron attributes if necessary. if (numberoftetrahedronattributes > 0) { tetrahedronattributelist = new REAL[numberoftetrahedra * numberoftetrahedronattributes]; - if (tetrahedronattributelist == (REAL *) NULL) { + if (tetrahedronattributelist == (REAL *) nullptr) { terminatetetgen(1); } } @@ -2018,7 +2018,7 @@ bool tetgenio::load_tetmesh(char* filebasename) infilename = inelefilename; } infile = fopen(infilename, "r"); - if (infile != (FILE *) NULL) { + if (infile != (FILE *) nullptr) { printf("Opening %s.\n", infilename); // Read number of faces, boundary markers. stringptr = readnumberline(inputline, infile, infilename); @@ -2035,12 +2035,12 @@ bool tetgenio::load_tetmesh(char* filebasename) } if (numberoftrifaces > 0) { trifacelist = new int[numberoftrifaces * 3]; - if (trifacelist == (int *) NULL) { + if (trifacelist == (int *) nullptr) { terminatetetgen(1); } if (markers) { trifacemarkerlist = new int[numberoftrifaces]; - if (trifacemarkerlist == (int *) NULL) { + if (trifacemarkerlist == (int *) nullptr) { terminatetetgen(1); } } @@ -2082,14 +2082,14 @@ bool tetgenio::load_tetmesh(char* filebasename) // Read the boundary edges from a .edge file if it exists. infilename = inedgefilename; infile = fopen(infilename, "r"); - if (infile != (FILE *) NULL) { + if (infile != (FILE *) nullptr) { printf("Opening %s.\n", infilename); // Read number of boundary edges. stringptr = readnumberline(inputline, infile, infilename); numberofedges = (int) strtol (stringptr, &stringptr, 0); if (numberofedges > 0) { edgelist = new int[numberofedges * 2]; - if (edgelist == (int *) NULL) { + if (edgelist == (int *) nullptr) { terminatetetgen(1); } stringptr = findnextnumber(stringptr); @@ -2134,7 +2134,7 @@ bool tetgenio::load_tetmesh(char* filebasename) // Read the volume constraints from a .vol file if it exists. infilename = involfilename; infile = fopen(infilename, "r"); - if (infile != (FILE *) NULL) { + if (infile != (FILE *) nullptr) { printf("Opening %s.\n", infilename); // Read number of tetrahedra. stringptr = readnumberline(inputline, infile, infilename); @@ -2146,7 +2146,7 @@ bool tetgenio::load_tetmesh(char* filebasename) } if (volelements > 0) { tetrahedronvolumelist = new REAL[volelements]; - if (tetrahedronvolumelist == (REAL *) NULL) { + if (tetrahedronvolumelist == (REAL *) nullptr) { terminatetetgen(1); } } @@ -2190,7 +2190,7 @@ void tetgenio::save_nodes(char* filebasename) printf("Saving nodes to %s\n", outnodefilename); fout = fopen(outnodefilename, "w"); fprintf(fout, "%d %d %d %d\n", numberofpoints, mesh_dim, - numberofpointattributes, pointmarkerlist != NULL ? 1 : 0); + numberofpointattributes, pointmarkerlist != nullptr ? 1 : 0); for (i = 0; i < numberofpoints; i++) { if (mesh_dim == 2) { fprintf(fout, "%d %.16g %.16g", i + firstnumber, pointlist[i * 3], @@ -2203,7 +2203,7 @@ void tetgenio::save_nodes(char* filebasename) fprintf(fout, " %.16g", pointattributelist[i * numberofpointattributes + j]); } - if (pointmarkerlist != NULL) { + if (pointmarkerlist != nullptr) { fprintf(fout, " %d", pointmarkerlist[i]); } fprintf(fout, "\n"); @@ -2211,7 +2211,7 @@ void tetgenio::save_nodes(char* filebasename) fclose(fout); // If the point metrics exist, output them to a .mtr file. - if ((numberofpointmtrs > 0) && (pointmtrlist != (REAL *) NULL)) { + if ((numberofpointmtrs > 0) && (pointmtrlist != (REAL *) nullptr)) { sprintf(outmtrfilename, "%s.mtr", filebasename); printf("Saving metrics to %s\n", outmtrfilename); fout = fopen(outmtrfilename, "w"); @@ -2263,7 +2263,7 @@ void tetgenio::save_elements(char* filebasename) for (j = 0; j < 3; j++) { fprintf(fout, " %5d", trifacelist[i * 3 + j]); } - if (trifacemarkerlist != NULL) { + if (trifacemarkerlist != nullptr) { fprintf(fout, " %d", trifacemarkerlist[i]); } fprintf(fout, "\n"); @@ -2289,11 +2289,11 @@ void tetgenio::save_faces(char* filebasename) printf("Saving faces to %s\n", outfacefilename); fout = fopen(outfacefilename, "w"); fprintf(fout, "%d %d\n", numberoftrifaces, - trifacemarkerlist != NULL ? 1 : 0); + trifacemarkerlist != nullptr ? 1 : 0); for (i = 0; i < numberoftrifaces; i++) { fprintf(fout, "%d %5d %5d %5d", i + firstnumber, trifacelist[i * 3], trifacelist[i * 3 + 1], trifacelist[i * 3 + 2]); - if (trifacemarkerlist != NULL) { + if (trifacemarkerlist != nullptr) { fprintf(fout, " %d", trifacemarkerlist[i]); } fprintf(fout, "\n"); @@ -2317,11 +2317,11 @@ void tetgenio::save_edges(char* filebasename) sprintf(outedgefilename, "%s.edge", filebasename); printf("Saving edges to %s\n", outedgefilename); fout = fopen(outedgefilename, "w"); - fprintf(fout, "%d %d\n", numberofedges, edgemarkerlist != NULL ? 1 : 0); + fprintf(fout, "%d %d\n", numberofedges, edgemarkerlist != nullptr ? 1 : 0); for (i = 0; i < numberofedges; i++) { fprintf(fout, "%d %4d %4d", i + firstnumber, edgelist[i * 2], edgelist[i * 2 + 1]); - if (edgemarkerlist != NULL) { + if (edgemarkerlist != nullptr) { fprintf(fout, " %d", edgemarkerlist[i]); } fprintf(fout, "\n"); @@ -2385,27 +2385,27 @@ void tetgenio::save_poly(char* filebasename) // Followed by number of dimensions, number of vertex attributes, // and number of boundary markers (zero or one). fprintf(fout, "%d %d %d %d\n", 0, mesh_dim, numberofpointattributes, - pointmarkerlist != NULL ? 1 : 0); + pointmarkerlist != nullptr ? 1 : 0); // Save segments or facets. if (mesh_dim == 2) { // Number of segments, number of boundary markers (zero or one). - fprintf(fout, "%d %d\n", numberofedges, edgemarkerlist != NULL ? 1 : 0); + fprintf(fout, "%d %d\n", numberofedges, edgemarkerlist != nullptr ? 1 : 0); for (i = 0; i < numberofedges; i++) { fprintf(fout, "%d %4d %4d", i + firstnumber, edgelist[i * 2], edgelist[i * 2 + 1]); - if (edgemarkerlist != NULL) { + if (edgemarkerlist != nullptr) { fprintf(fout, " %d", edgemarkerlist[i]); } fprintf(fout, "\n"); } } else { // Number of facets, number of boundary markers (zero or one). - fprintf(fout, "%d %d\n", numberoffacets, facetmarkerlist != NULL ? 1 : 0); + fprintf(fout, "%d %d\n", numberoffacets, facetmarkerlist != nullptr ? 1 : 0); for (i = 0; i < numberoffacets; i++) { f = &(facetlist[i]); fprintf(fout, "%d %d %d # %d\n", f->numberofpolygons,f->numberofholes, - facetmarkerlist != NULL ? facetmarkerlist[i] : 0, i + firstnumber); + facetmarkerlist != nullptr ? facetmarkerlist[i] : 0, i + firstnumber); // Output polygons of this facet. for (j = 0; j < f->numberofpolygons; j++) { p = &(f->polygonlist[j]); @@ -2481,8 +2481,8 @@ char* tetgenio::readline(char *string, FILE *infile, int *linenumber) do { result = fgets(string, INPUTLINESIZE - 1, infile); if (linenumber) (*linenumber)++; - if (result == (char *) NULL) { - return (char *) NULL; + if (result == (char *) nullptr) { + return (char *) nullptr; } // Skip white spaces. while ((*result == ' ') || (*result == '\t')) result++; @@ -2535,8 +2535,8 @@ char* tetgenio::readnumberline(char *string, FILE *infile, char *infilename) // Search for something that looks like a number. do { result = fgets(string, INPUTLINESIZE, infile); - if (result == (char *) NULL) { - if (infilename != (char *) NULL) { + if (result == (char *) nullptr) { + if (infilename != (char *) nullptr) { printf(" Error: Unexpected end of file in %s.\n", infilename); terminatetetgen(1); } @@ -2783,11 +2783,11 @@ bool tetgenbehavior::parse_commandline(int argc, char **argv) } workstring[k] = '\0'; if (quality == 1) { - minratio = (REAL) strtod(workstring, (char **) NULL); + minratio = (REAL) strtod(workstring, (char **) nullptr); } else if (quality == 2) { - mindihedral = (REAL) strtod(workstring, (char **) NULL); + mindihedral = (REAL) strtod(workstring, (char **) nullptr); } else if (quality == 3) { - maxdihedral = (REAL) strtod(workstring, (char **) NULL); + maxdihedral = (REAL) strtod(workstring, (char **) nullptr); } } } else if (argv[i][j] == 'm') { @@ -2803,9 +2803,9 @@ bool tetgenbehavior::parse_commandline(int argc, char **argv) } workstring[k] = '\0'; if (metric == 1) { - alpha1 = (REAL) strtod(workstring, (char **) NULL); + alpha1 = (REAL) strtod(workstring, (char **) nullptr); } else if (metric == 2) { - alpha2 = (REAL) strtod(workstring, (char **) NULL); + alpha2 = (REAL) strtod(workstring, (char **) nullptr); } } } else if (argv[i][j] == 'a') { @@ -2821,7 +2821,7 @@ bool tetgenbehavior::parse_commandline(int argc, char **argv) k++; } workstring[k] = '\0'; - maxvolume = (REAL) strtod(workstring, (char **) NULL); + maxvolume = (REAL) strtod(workstring, (char **) nullptr); } else { varvolume = 1; } @@ -2839,7 +2839,7 @@ bool tetgenbehavior::parse_commandline(int argc, char **argv) k++; } workstring[k] = '\0'; - max_btreenode_size = (int) strtol(workstring, (char **) NULL, 0); + max_btreenode_size = (int) strtol(workstring, (char **) nullptr, 0); } if (max_btreenode_size == 0) { btree = 0; @@ -2903,7 +2903,7 @@ bool tetgenbehavior::parse_commandline(int argc, char **argv) k++; } workstring[k] = '\0'; - steiner = (int) strtol(workstring, (char **) NULL, 0); + steiner = (int) strtol(workstring, (char **) nullptr, 0); } } else if (argv[i][j] == 's') { scount++; @@ -2919,9 +2919,9 @@ bool tetgenbehavior::parse_commandline(int argc, char **argv) } workstring[k] = '\0'; if (scount == 1) { - optlevel = (int) strtol(workstring, (char **) NULL, 0); + optlevel = (int) strtol(workstring, (char **) nullptr, 0); } else if (scount == 2) { - optpasses = (int) strtol(workstring, (char **) NULL, 0); + optpasses = (int) strtol(workstring, (char **) nullptr, 0); } } } else if (argv[i][j] == 'D') { @@ -2938,7 +2938,7 @@ bool tetgenbehavior::parse_commandline(int argc, char **argv) k++; } workstring[k] = '\0'; - epsilon = (REAL) strtod(workstring, (char **) NULL); + epsilon = (REAL) strtod(workstring, (char **) nullptr); } } else if (argv[i][j] == 'C') { docheck++; @@ -3219,7 +3219,7 @@ void tetgenmesh::getnextsface(face* s1, face* s2) if (sorg(neighsh) != sorg(*s1)) { sesymself(neighsh); } - if (s2 != (face *) NULL) { + if (s2 != (face *) nullptr) { *s2 = neighsh; } else { *s1 = neighsh; @@ -3255,7 +3255,7 @@ void tetgenmesh::tsspivot(triface* checkedge, face* checkseg) do { tspivot(spintet, parentsh); // Does spintet have a (non-fake) subface attached? - if ((parentsh.sh != dummysh) && (sapex(parentsh) != NULL)) { + if ((parentsh.sh != dummysh) && (sapex(parentsh) != nullptr)) { // Find a subface! Find the edge in it. findedge(&parentsh, org(*checkedge), dest(*checkedge)); sspivot(parentsh, *checkseg); @@ -3330,7 +3330,7 @@ void tetgenmesh::point2tetorg(point pa, triface& searchtet) // Search a tet whose origin is pa. decode(point2tet(pa), searchtet); - if (searchtet.tet == NULL) { + if (searchtet.tet == nullptr) { printf("Internal error: %d contains bad tet pointer.\n", pointmark(pa)); terminatetetgen(2); } @@ -3355,7 +3355,7 @@ void tetgenmesh::point2tetorg(point pa, triface& searchtet) void tetgenmesh::point2shorg(point pa, face& searchsh) { sdecode(point2sh(pa), searchsh); - if (searchsh.sh == NULL) { + if (searchsh.sh == nullptr) { printf("Internal error: %d contains bad sub pointer.\n", pointmark(pa)); terminatetetgen(2); } @@ -3374,7 +3374,7 @@ void tetgenmesh::point2shorg(point pa, face& searchsh) void tetgenmesh::point2segorg(point pa, face& searchsh) { sdecode(point2seg(pa), searchsh); - if (searchsh.sh == NULL) { + if (searchsh.sh == nullptr) { printf("Internal error: %d contains bad seg pointer.\n", pointmark(pa)); terminatetetgen(2); } @@ -3689,7 +3689,7 @@ void tetgenmesh::printtet(triface* tface) } tmppt = org(*tface); - if(tmppt == (point) NULL) { + if(tmppt == (point) nullptr) { printf(" Org [%i] NULL\n", locver2org[tface->loc][tface->ver]); } else { printf(" Org [%i] x%lx (%.12g,%.12g,%.12g) %d\n", @@ -3697,7 +3697,7 @@ void tetgenmesh::printtet(triface* tface) tmppt[0], tmppt[1], tmppt[2], pointmark(tmppt)); } tmppt = dest(*tface); - if(tmppt == (point) NULL) { + if(tmppt == (point) nullptr) { printf(" Dest[%i] NULL\n", locver2dest[tface->loc][tface->ver]); } else { printf(" Dest[%i] x%lx (%.12g,%.12g,%.12g) %d\n", @@ -3705,7 +3705,7 @@ void tetgenmesh::printtet(triface* tface) tmppt[0], tmppt[1], tmppt[2], pointmark(tmppt)); } tmppt = apex(*tface); - if(tmppt == (point) NULL) { + if(tmppt == (point) nullptr) { printf(" Apex[%i] NULL\n", locver2apex[tface->loc][tface->ver]); } else { printf(" Apex[%i] x%lx (%.12g,%.12g,%.12g) %d\n", @@ -3713,7 +3713,7 @@ void tetgenmesh::printtet(triface* tface) tmppt[0], tmppt[1], tmppt[2], pointmark(tmppt)); } tmppt = oppo(*tface); - if(tmppt == (point) NULL) { + if(tmppt == (point) nullptr) { printf(" Oppo[%i] NULL\n", loc2oppo[tface->loc]); } else { printf(" Oppo[%i] x%lx (%.12g,%.12g,%.12g) %d\n", @@ -3722,7 +3722,7 @@ void tetgenmesh::printtet(triface* tface) } if (b->useshelles) { - if (tface->tet[8] != NULL) { + if (tface->tet[8] != nullptr) { shells = (shellface *) tface->tet[8]; for (facecount = 0; facecount < 6; facecount++) { sdecode(shells[facecount], checksh); @@ -3738,7 +3738,7 @@ void tetgenmesh::printtet(triface* tface) printf("\n"); } } - if (tface->tet[9] != NULL) { + if (tface->tet[9] != nullptr) { shells = (shellface *) tface->tet[9]; for (facecount = 0; facecount < 4; facecount++) { sdecode(shells[facecount], checksh); @@ -3771,7 +3771,7 @@ void tetgenmesh::printsh(face* sface) triface prttet; point printpoint; - if (sapex(*sface) != NULL) { + if (sapex(*sface) != nullptr) { printf("subface x%lx, ver %d, mark %d:", (uintptr_t)(sface->sh), sface->shver, shellmark(*sface)); } else { @@ -3787,7 +3787,7 @@ void tetgenmesh::printsh(face* sface) if (shell2badface(*sface)) { printf(" (queued)"); } - if (sapex(*sface) != NULL) { + if (sapex(*sface) != nullptr) { if (shelltype(*sface) == SHARP) { printf(" (sharp)"); } @@ -3823,23 +3823,23 @@ void tetgenmesh::printsh(face* sface) } printpoint = sorg(*sface); - if (printpoint == (point) NULL) + if (printpoint == (point) nullptr) printf(" Org [%d] = NULL\n", vo[sface->shver]); else printf(" Org [%d] = x%lx (%.12g,%.12g,%.12g) %d\n", vo[sface->shver], (uintptr_t)(printpoint), printpoint[0], printpoint[1], printpoint[2], pointmark(printpoint)); printpoint = sdest(*sface); - if (printpoint == (point) NULL) + if (printpoint == (point) nullptr) printf(" Dest[%d] = NULL\n", vd[sface->shver]); else printf(" Dest[%d] = x%lx (%.12g,%.12g,%.12g) %d\n", vd[sface->shver], (uintptr_t)(printpoint), printpoint[0], printpoint[1], printpoint[2], pointmark(printpoint)); - if (sapex(*sface) != NULL) { + if (sapex(*sface) != nullptr) { printpoint = sapex(*sface); - if (printpoint == (point) NULL) + if (printpoint == (point) nullptr) printf(" Apex[%d] = NULL\n", va[sface->shver]); else printf(" Apex[%d] = x%lx (%.12g,%.12g,%.12g) %d\n", @@ -3929,7 +3929,7 @@ void tetgenmesh::arraypool::poolinit(int sizeofobject, int log2objperblk) // No memory has been allocated. totalmemory = 0l; // The top array has not been allocated yet. - toparray = (char **) NULL; + toparray = (char **) nullptr; toparraylen = 0; // Ready all indices to be allocated. @@ -3952,11 +3952,11 @@ tetgenmesh::arraypool::~arraypool() int i; // Has anything been allocated at all? - if (toparray != (char **) NULL) { + if (toparray != (char **) nullptr) { // Walk through the top array. for (i = 0; i < toparraylen; i++) { // Check every pointer; NULLs may be scattered randomly. - if (toparray[i] != (char *) NULL) { + if (toparray[i] != (char *) nullptr) { // Free an allocated block. free((void *) toparray[i]); } @@ -3966,7 +3966,7 @@ tetgenmesh::arraypool::~arraypool() } // The top array is no longer allocated. - toparray = (char **) NULL; + toparray = (char **) nullptr; toparraylen = 0; objects = 0; totalmemory = 0; @@ -3995,14 +3995,14 @@ char* tetgenmesh::arraypool::getblock(int objectindex) // Compute the index in the top array (upper bits). topindex = objectindex >> log2objectsperblock; // Does the top array need to be allocated or resized? - if (toparray == (char **) NULL) { + if (toparray == (char **) nullptr) { // Allocate the top array big enough to hold 'topindex', and NULL out // its contents. newsize = topindex + 128; toparray = (char **) malloc((size_t) (newsize * sizeof(char *))); toparraylen = newsize; for (i = 0; i < newsize; i++) { - toparray[i] = (char *) NULL; + toparray[i] = (char *) nullptr; } // Account for the memory. totalmemory = newsize * (unsigned long) sizeof(char *); @@ -4019,7 +4019,7 @@ char* tetgenmesh::arraypool::getblock(int objectindex) newarray[i] = toparray[i]; } for (i = toparraylen; i < newsize; i++) { - newarray[i] = (char *) NULL; + newarray[i] = (char *) nullptr; } free(toparray); // Account for the memory. @@ -4030,7 +4030,7 @@ char* tetgenmesh::arraypool::getblock(int objectindex) // Find the block, or learn that it hasn't been allocated yet. block = toparray[topindex]; - if (block == (char *) NULL) { + if (block == (char *) nullptr) { // Allocate a block at this index. block = (char *) malloc((size_t) (objectsperblock * objectbytes)); toparray[topindex] = block; @@ -4055,21 +4055,21 @@ void* tetgenmesh::arraypool::lookup(int objectindex) int topindex; // Has the top array been allocated yet? - if (toparray == (char **) NULL) { - return (void *) NULL; + if (toparray == (char **) nullptr) { + return (void *) nullptr; } // Compute the index in the top array (upper bits). topindex = objectindex >> log2objectsperblock; // Does the top index fit in the top array? if (topindex >= toparraylen) { - return (void *) NULL; + return (void *) nullptr; } // Find the block, or learn that it hasn't been allocated yet. block = toparray[topindex]; - if (block == (char *) NULL) { - return (void *) NULL; + if (block == (char *) nullptr) { + return (void *) nullptr; } // Compute a pointer to the object with the given index. Note that @@ -4096,7 +4096,7 @@ int tetgenmesh::arraypool::newindex(void **newptr) objects++; // If 'newptr' is not NULL, use it to return a pointer to the object. - if (newptr != (void **) NULL) { + if (newptr != (void **) nullptr) { *newptr = newobject; } return newindex; @@ -4120,7 +4120,7 @@ void tetgenmesh::list::listinit(int itbytes, compfunc pcomp, int mitems, maxitems = mitems; expandsize = exsize; base = (char *) malloc(maxitems * itembytes); - if (base == (char *) NULL) { + if (base == (char *) nullptr) { terminatetetgen(1); } items = 0; @@ -4143,13 +4143,13 @@ void* tetgenmesh::list::append(void *appitem) if (items == maxitems) { char* newbase = (char *) realloc(base, (maxitems + expandsize) * itembytes); - if (newbase == (char *) NULL) { + if (newbase == (char *) nullptr) { terminatetetgen(1); } base = newbase; maxitems += expandsize; } - if (appitem != (void *) NULL) { + if (appitem != (void *) nullptr) { memcpy(base + items * itembytes, appitem, itembytes); } items++; @@ -4176,7 +4176,7 @@ void* tetgenmesh::list::insert(int pos, void* insitem) if (items == maxitems) { char* newbase = (char *) realloc(base, (maxitems + expandsize) * itembytes); - if (newbase == (char *) NULL) { + if (newbase == (char *) nullptr) { terminatetetgen(1); } base = newbase; @@ -4187,7 +4187,7 @@ void* tetgenmesh::list::insert(int pos, void* insitem) base + pos * itembytes, // src (items - pos) * itembytes); // size in bytes // Insert the item. - if (insitem != (void *) NULL) { + if (insitem != (void *) nullptr) { memcpy(base + pos * itembytes, insitem, itembytes); } items++; @@ -4241,7 +4241,7 @@ int tetgenmesh::list::hasitem(void* checkitem) int i; for (i = 0; i < items; i++) { - if (comp != (compfunc) NULL) { + if (comp != (compfunc) nullptr) { if ((* comp)((void *)(base + i * itembytes), checkitem) == 0) { return i; } @@ -4258,11 +4258,11 @@ int tetgenmesh::list::hasitem(void* checkitem) tetgenmesh::memorypool::memorypool() { - firstblock = nowblock = (void **) NULL; - nextitem = (void *) NULL; - deaditemstack = (void *) NULL; - pathblock = (void **) NULL; - pathitem = (void *) NULL; + firstblock = nowblock = (void **) nullptr; + nextitem = (void *) nullptr; + deaditemstack = (void *) nullptr; + pathblock = (void **) nullptr; + pathitem = (void *) nullptr; itemwordtype = POINTER; alignbytes = 0; itembytes = itemwords = 0; @@ -4286,7 +4286,7 @@ memorypool(int bytecount, int itemcount, enum wordtype wtype, int alignment) tetgenmesh::memorypool::~memorypool() { - while (firstblock != (void **) NULL) { + while (firstblock != (void **) nullptr) { nowblock = (void **) *(firstblock); free(firstblock); firstblock = nowblock; @@ -4340,11 +4340,11 @@ poolinit(int bytecount, int itemcount, enum wordtype wtype, int alignment) // to ensure alignment of the items. firstblock = (void **) malloc(itemsperblock * itembytes + sizeof(void *) + alignbytes); - if (firstblock == (void **) NULL) { + if (firstblock == (void **) nullptr) { terminatetetgen(1); } // Set the next block pointer to NULL. - *(firstblock) = (void *) NULL; + *(firstblock) = (void *) nullptr; restart(); } @@ -4381,7 +4381,7 @@ void tetgenmesh::memorypool::restart() // There are lots of unallocated items left in this block. unallocateditems = itemsperblock; // The stack of deallocated items is empty. - deaditemstack = (void *) NULL; + deaditemstack = (void *) nullptr; } /////////////////////////////////////////////////////////////////////////////// @@ -4399,23 +4399,23 @@ void* tetgenmesh::memorypool::alloc() // First check the linked list of dead items. If the list is not // empty, allocate an item from the list rather than a fresh one. - if (deaditemstack != (void *) NULL) { + if (deaditemstack != (void *) nullptr) { newitem = deaditemstack; // Take first item in list. deaditemstack = * (void **) deaditemstack; } else { // Check if there are any free items left in the current block. if (unallocateditems == 0) { // Check if another block must be allocated. - if (*nowblock == (void *) NULL) { + if (*nowblock == (void *) nullptr) { // Allocate a new block of items, pointed to by the previous block. newblock = (void **) malloc(itemsperblock * itembytes + sizeof(void *) + alignbytes); - if (newblock == (void **) NULL) { + if (newblock == (void **) nullptr) { terminatetetgen(1); } *nowblock = (void *) newblock; // The next block pointer is NULL. - *newblock = (void *) NULL; + *newblock = (void *) nullptr; } // Move to the new block. nowblock = (void **) *nowblock; @@ -4513,7 +4513,7 @@ void* tetgenmesh::memorypool::traverse() // Stop upon exhausting the list of items. if (pathitem == nextitem) { - return (void *) NULL; + return (void *) nullptr; } // Check whether any untraversed items remain in the current block. if (pathitemsleft == 0) { @@ -4566,14 +4566,14 @@ void tetgenmesh::makepoint2tetmap() // Initialize the point2tet field of each point. points->traversalinit(); pointptr = pointtraverse(); - while (pointptr != (point) NULL) { - setpoint2tet(pointptr, (tetrahedron) NULL); + while (pointptr != (point) nullptr) { + setpoint2tet(pointptr, (tetrahedron) nullptr); pointptr = pointtraverse(); } tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Check all four points of the tetrahedron. tetloop.loc = 0; pointptr = org(tetloop); @@ -4601,7 +4601,7 @@ void tetgenmesh::makepoint2segmap() segloop.shver = 0; subsegs->traversalinit(); segloop.sh = shellfacetraverse(subsegs); - while (segloop.sh != NULL) { + while (segloop.sh != nullptr) { ppt = (point *) &(segloop.sh[3]); setpoint2seg(ppt[0], sencode(segloop)); setpoint2seg(ppt[1], sencode(segloop)); @@ -4634,7 +4634,7 @@ void tetgenmesh::makeindex2pointmap(point*& idx2verlist) points->traversalinit(); pointloop = pointtraverse(); idx = 0; - while (pointloop != (point) NULL) { + while (pointloop != (point) nullptr) { idx2verlist[idx] = pointloop; idx++; pointloop = pointtraverse(); @@ -4678,7 +4678,7 @@ void tetgenmesh::makesegmentmap(int*& idx2seglist, shellface**& segsperverlist) // each vertex. subsegs->traversalinit(); shloop = shellfacetraverse(subsegs); - while (shloop != (shellface *) NULL) { + while (shloop != (shellface *) nullptr) { // Increment the number of sharing segments for each endpoint. for (i = 0; i < 2; i++) { j = pointmark((point) shloop[3 + i]) - in->firstnumber; @@ -4700,7 +4700,7 @@ void tetgenmesh::makesegmentmap(int*& idx2seglist, shellface**& segsperverlist) // Loop the set of segments again, set the info. of segments per vertex. subsegs->traversalinit(); shloop = shellfacetraverse(subsegs); - while (shloop != (shellface *) NULL) { + while (shloop != (shellface *) nullptr) { for (i = 0; i < 2; i++) { j = pointmark((point) shloop[3 + i]) - in->firstnumber; segsperverlist[idx2seglist[j]] = shloop; @@ -4733,7 +4733,7 @@ void tetgenmesh::makesubfacemap(int*& idx2facelist, // each vertex. subfaces->traversalinit(); shloop = shellfacetraverse(subfaces); - while (shloop != (shellface *) NULL) { + while (shloop != (shellface *) nullptr) { // Increment the number of sharing segments for each endpoint. for (i = 0; i < 3; i++) { j = pointmark((point) shloop[3 + i]) - in->firstnumber; @@ -4755,7 +4755,7 @@ void tetgenmesh::makesubfacemap(int*& idx2facelist, // Loop the set of segments again, set the info. of segments per vertex. subfaces->traversalinit(); shloop = shellfacetraverse(subfaces); - while (shloop != (shellface *) NULL) { + while (shloop != (shellface *) nullptr) { for (i = 0; i < 3; i++) { j = pointmark((point) shloop[3 + i]) - in->firstnumber; facesperverlist[idx2facelist[j]] = shloop; @@ -4788,7 +4788,7 @@ void tetgenmesh::maketetrahedronmap(int*& idx2tetlist, // sharing each vertex. tetrahedrons->traversalinit(); tetloop = tetrahedrontraverse(); - while (tetloop != (tetrahedron *) NULL) { + while (tetloop != (tetrahedron *) nullptr) { // Increment the number of sharing tetrahedra for each endpoint. for (i = 0; i < 4; i++) { j = pointmark((point) tetloop[4 + i]) - in->firstnumber; @@ -4810,7 +4810,7 @@ void tetgenmesh::maketetrahedronmap(int*& idx2tetlist, // Loop the set of tetrahedra again, set the info. of tet. per vertex. tetrahedrons->traversalinit(); tetloop = tetrahedrontraverse(); - while (tetloop != (tetrahedron *) NULL) { + while (tetloop != (tetrahedron *) nullptr) { for (i = 0; i < 4; i++) { j = pointmark((point) tetloop[4 + i]) - in->firstnumber; tetsperverlist[idx2tetlist[j]] = tetloop; @@ -4862,10 +4862,10 @@ void tetgenmesh::dummyinit(int tetwords, int shwords) dummytet[2] = (tetrahedron) dummytet; dummytet[3] = (tetrahedron) dummytet; // Four null vertex points. - dummytet[4] = (tetrahedron) NULL; - dummytet[5] = (tetrahedron) NULL; - dummytet[6] = (tetrahedron) NULL; - dummytet[7] = (tetrahedron) NULL; + dummytet[4] = (tetrahedron) nullptr; + dummytet[5] = (tetrahedron) nullptr; + dummytet[6] = (tetrahedron) nullptr; + dummytet[7] = (tetrahedron) nullptr; if (b->useshelles) { // Set up 'dummysh', the omnipresent "subface" pointed to by any @@ -4886,9 +4886,9 @@ void tetgenmesh::dummyinit(int tetwords, int shwords) dummysh[1] = (shellface) dummysh; dummysh[2] = (shellface) dummysh; // Three null vertex points. - dummysh[3] = (shellface) NULL; - dummysh[4] = (shellface) NULL; - dummysh[5] = (shellface) NULL; + dummysh[3] = (shellface) nullptr; + dummysh[4] = (shellface) nullptr; + dummysh[5] = (shellface) nullptr; // Initialize the two adjoining tetrahedra to be "outer space". dummysh[6] = (shellface) dummytet; dummysh[7] = (shellface) dummytet; @@ -4897,11 +4897,11 @@ void tetgenmesh::dummyinit(int tetwords, int shwords) dummysh[9] = (shellface) dummysh; dummysh[10] = (shellface) dummysh; // Initialize the pointer to badface structure. - dummysh[11] = (shellface) NULL; + dummysh[11] = (shellface) nullptr; // Initialize the four adjoining subfaces of 'dummytet' to be the // omnipresent subface. - dummytet[8 ] = NULL; - dummytet[9 ] = NULL; + dummytet[8 ] = nullptr; + dummytet[9 ] = nullptr; } } @@ -4929,7 +4929,7 @@ void tetgenmesh::initializepools() int pointsize, elesize, shsize; // Default checkpbc = 0; - if ((b->plc || b->refine) && (in->pbcgrouplist != NULL)) { + if ((b->plc || b->refine) && (in->pbcgrouplist != nullptr)) { checkpbcs = 1; } // Default varconstraint = 0; @@ -4943,9 +4943,9 @@ void tetgenmesh::initializepools() // Decide the size (1, 3, or 6) of the metric tensor. if (b->metric) { // For '-m' option. A tensor field is provided (*.mtr or *.b.mtr file). - if (bgm != (tetgenmesh *) NULL) { + if (bgm != (tetgenmesh *) nullptr) { // A background mesh is allocated. It may not exist though. - sizeoftensor = (bgm->in != (tetgenio *) NULL) ? + sizeoftensor = (bgm->in != (tetgenio *) nullptr) ? bgm->in->numberofpointmtrs : in->numberofpointmtrs; } else { // No given background mesh - Itself is a background mesh. @@ -5105,17 +5105,17 @@ void tetgenmesh::tetrahedrondealloc(tetrahedron *dyingtetrahedron) { // Set tetrahedron's vertices to NULL. This makes it possible to detect // dead tetrahedra when traversing the list of all tetrahedra. - dyingtetrahedron[4] = (tetrahedron) NULL; + dyingtetrahedron[4] = (tetrahedron) nullptr; // dyingtetrahedron[5] = (tetrahedron) NULL; // dyingtetrahedron[6] = (tetrahedron) NULL; - dyingtetrahedron[7] = (tetrahedron) NULL; + dyingtetrahedron[7] = (tetrahedron) nullptr; if (b->useshelles) { // Dealloc the space to subfaces/subsegments. - if (dyingtetrahedron[8] != NULL) { + if (dyingtetrahedron[8] != nullptr) { tet2segpool->dealloc((shellface *) dyingtetrahedron[8]); } - if (dyingtetrahedron[9] != NULL) { + if (dyingtetrahedron[9] != nullptr) { tet2subpool->dealloc((shellface *) dyingtetrahedron[9]); } } @@ -5135,10 +5135,10 @@ tetgenmesh::tetrahedron* tetgenmesh::tetrahedrontraverse() do { newtetrahedron = (tetrahedron *) tetrahedrons->traverse(); - if (newtetrahedron == (tetrahedron *) NULL) { - return (tetrahedron *) NULL; + if (newtetrahedron == (tetrahedron *) nullptr) { + return (tetrahedron *) nullptr; } - } while (newtetrahedron[7] == (tetrahedron) NULL); // Skip dead ones. + } while (newtetrahedron[7] == (tetrahedron) nullptr); // Skip dead ones. return newtetrahedron; } @@ -5153,9 +5153,9 @@ void tetgenmesh::shellfacedealloc(memorypool *pool, shellface *dyingsh) { // Set shellface's vertices to NULL. This makes it possible to detect dead // shellfaces when traversing the list of all shellfaces. - dyingsh[3] = (shellface) NULL; - dyingsh[4] = (shellface) NULL; - dyingsh[5] = (shellface) NULL; + dyingsh[3] = (shellface) nullptr; + dyingsh[4] = (shellface) nullptr; + dyingsh[5] = (shellface) nullptr; pool->dealloc((void *) dyingsh); } @@ -5172,10 +5172,10 @@ tetgenmesh::shellface* tetgenmesh::shellfacetraverse(memorypool *pool) do { newshellface = (shellface *) pool->traverse(); - if (newshellface == (shellface *) NULL) { - return (shellface *) NULL; + if (newshellface == (shellface *) nullptr) { + return (shellface *) nullptr; } - } while (newshellface[3] == (shellface) NULL); // Skip dead ones. + } while (newshellface[3] == (shellface) nullptr); // Skip dead ones. return newshellface; } @@ -5189,7 +5189,7 @@ void tetgenmesh::badfacedealloc(memorypool *pool, badface *dying) { // Set badface's forg to NULL. This makes it possible to detect dead // ones when traversing the list of all items. - dying->forg = (point) NULL; + dying->forg = (point) nullptr; pool->dealloc((void *) dying); } @@ -5205,10 +5205,10 @@ tetgenmesh::badface* tetgenmesh::badfacetraverse(memorypool *pool) do { newsh = (badface *) pool->traverse(); - if (newsh == (badface *) NULL) { - return (badface *) NULL; + if (newsh == (badface *) nullptr) { + return (badface *) nullptr; } - } while (newsh->forg == (point) NULL); // Skip dead ones. + } while (newsh->forg == (point) nullptr); // Skip dead ones. return newsh; } @@ -5238,8 +5238,8 @@ tetgenmesh::point tetgenmesh::pointtraverse() do { newpoint = (point) points->traverse(); - if (newpoint == (point) NULL) { - return (point) NULL; + if (newpoint == (point) nullptr) { + return (point) nullptr; } } while (pointtype(newpoint) == DEADVERTEX); // Skip dead ones. return newpoint; @@ -5260,14 +5260,14 @@ void tetgenmesh::maketetrahedron(triface *newtet) newtet->tet[2] = (tetrahedron) dummytet; newtet->tet[3] = (tetrahedron) dummytet; // Four NULL vertices. - newtet->tet[4] = (tetrahedron) NULL; - newtet->tet[5] = (tetrahedron) NULL; - newtet->tet[6] = (tetrahedron) NULL; - newtet->tet[7] = (tetrahedron) NULL; + newtet->tet[4] = (tetrahedron) nullptr; + newtet->tet[5] = (tetrahedron) nullptr; + newtet->tet[6] = (tetrahedron) nullptr; + newtet->tet[7] = (tetrahedron) nullptr; // Initialize the four adjoining subfaces to be the omnipresent subface. if (b->useshelles) { - newtet->tet[8 ] = NULL; - newtet->tet[9 ] = NULL; + newtet->tet[8 ] = nullptr; + newtet->tet[9 ] = nullptr; } for (int i = 0; i < in->numberoftetrahedronattributes; i++) { setelemattribute(newtet->tet, i, 0.0); @@ -5297,9 +5297,9 @@ void tetgenmesh::makeshellface(memorypool *pool, face *newface) newface->sh[1] = (shellface) dummysh; newface->sh[2] = (shellface) dummysh; // Three NULL vertices. - newface->sh[3] = (shellface) NULL; - newface->sh[4] = (shellface) NULL; - newface->sh[5] = (shellface) NULL; + newface->sh[3] = (shellface) nullptr; + newface->sh[4] = (shellface) nullptr; + newface->sh[5] = (shellface) nullptr; // Initialize the two adjoining tetrahedra to be "outer space". newface->sh[6] = (shellface) dummytet; newface->sh[7] = (shellface) dummytet; @@ -5309,7 +5309,7 @@ void tetgenmesh::makeshellface(memorypool *pool, face *newface) newface->sh [9] = (shellface) dummysh; newface->sh[10] = (shellface) dummysh; // Initialize the pointer to badface structure. - newface->sh[11] = (shellface) NULL; + newface->sh[11] = (shellface) nullptr; if (b->quality && varconstraint) { // Initialize the maximum area bound. setareabound(*newface, 0.0); @@ -5354,16 +5354,16 @@ void tetgenmesh::makepoint(point* pnewpoint) } if (b->plc || b->refine) { // Initialize the point-to-simplex filed. - setpoint2tet(*pnewpoint, NULL); - setpoint2sh(*pnewpoint, NULL); - setpoint2seg(*pnewpoint, NULL); - setpoint2ppt(*pnewpoint, NULL); + setpoint2tet(*pnewpoint, nullptr); + setpoint2sh(*pnewpoint, nullptr); + setpoint2seg(*pnewpoint, nullptr); + setpoint2ppt(*pnewpoint, nullptr); if (b->metric) { - setpoint2bgmtet(*pnewpoint, NULL); + setpoint2bgmtet(*pnewpoint, nullptr); } if (checkpbcs) { // Initialize the other pointer to its pbc point. - setpoint2pbcpt(*pnewpoint, NULL); + setpoint2pbcpt(*pnewpoint, nullptr); } } // Initialize the point marker (starting from in->firstnumber). @@ -6108,7 +6108,7 @@ int tetgenmesh::tri_edge_2d(point A, point B, point C, point P, point Q, REAL s1, s2, s3, s4; int z1; - if (R == NULL) { + if (R == nullptr) { REAL n[3], len; // Calculate a lift point, saved in dummypoint. facenormal2(A, B, C, n, 1); @@ -6977,12 +6977,12 @@ REAL tetgenmesh::incircle3d(point pa, point pb, point pc, point pd) if (area2[0] > area2[1]) { // Choose [a, b, c] as the base triangle. - circumsphere(pa, pb, pc, NULL, c, &r); + circumsphere(pa, pb, pc, nullptr, c, &r); d = DIST(c, pd); } else { // Choose [b, a, d] as the base triangle. if (area2[1] > 0) { - circumsphere(pb, pa, pd, NULL, c, &r); + circumsphere(pb, pa, pd, nullptr, c, &r); d = DIST(c, pc); } else { // The four points are collinear. This case only happens on the boundary. @@ -7434,7 +7434,7 @@ REAL tetgenmesh::interiorangle(REAL* o, REAL* p1, REAL* p2, REAL* n) costheta = -1.0; // Roundoff. } theta = acos(costheta); - if (n != NULL) { + if (n != nullptr) { // Get a point above the face (o, p1, p2); np[0] = o[0] + n[0]; np[1] = o[1] + n[1]; @@ -7536,7 +7536,7 @@ void tetgenmesh::facenormal(REAL* pa, REAL* pb, REAL* pc, REAL* n, REAL* nlen) v2[2] = pc[2] - pa[2]; cross(v1, v2, n); - if (nlen != (REAL *) NULL) { + if (nlen != (REAL *) nullptr) { *nlen = sqrt(dot(n, n)); } } @@ -7702,16 +7702,16 @@ void tetgenmesh::tetalldihedral(point pa, point pb, point pc, point pd, if (vol == 0.0) { // This tet is not valid. - if (cosdd != NULL) { + if (cosdd != nullptr) { for (i = 0; i < 6; i++) { cosdd[i] = -1.0; // 180 degree. } } // This tet has zero volume. - if (cosmaxd != NULL) { + if (cosmaxd != nullptr) { *cosmaxd = -1.0; // 180 degree. } - if (cosmind != NULL) { + if (cosmind != nullptr) { *cosmind = 1.0; // 0 degree. } return; @@ -7768,7 +7768,7 @@ void tetgenmesh::tetallnormal(point pa, point pb, point pc, point pd, for (i = 0; i < 3; i++) A[2][i] = pc[i] - pd[i]; // d->c vec // Compute the inverse of matrix A, to get 3 normals of the 4 faces. lu_decmp(A, 3, indx, &D, 0); // Decompose the matrix just once. - if (volume != NULL) { + if (volume != nullptr) { // Get the volume of the tet. *volume = fabs((A[indx[0]][0] * A[indx[1]][1] * A[indx[2]][2])) / 6.0; } @@ -7876,7 +7876,7 @@ circumsphere(REAL* pa, REAL* pb, REAL* pc, REAL* pd, REAL* cent, REAL* radius) A[1][0] = pc[0] - pa[0]; A[1][1] = pc[1] - pa[1]; A[1][2] = pc[2] - pa[2]; - if (pd != NULL) { + if (pd != nullptr) { A[2][0] = pd[0] - pa[0]; A[2][1] = pd[1] - pa[1]; A[2][2] = pd[2] - pa[2]; @@ -7887,7 +7887,7 @@ circumsphere(REAL* pa, REAL* pb, REAL* pc, REAL* pd, REAL* cent, REAL* radius) // Compute the right hand side vector b (3x1). rhs[0] = 0.5 * dot(A[0], A[0]); rhs[1] = 0.5 * dot(A[1], A[1]); - if (pd != NULL) { + if (pd != nullptr) { rhs[2] = 0.5 * dot(A[2], A[2]); } else { rhs[2] = 0.0; @@ -7896,16 +7896,16 @@ circumsphere(REAL* pa, REAL* pb, REAL* pc, REAL* pd, REAL* cent, REAL* radius) // Solve the 3 by 3 equations use LU decomposition with partial pivoting // and backward and forward substitute.. if (!lu_decmp(A, 3, indx, &D, 0)) { - if (radius != (REAL *) NULL) *radius = 0.0; + if (radius != (REAL *) nullptr) *radius = 0.0; return false; } lu_solve(A, 3, indx, rhs, 0); - if (cent != (REAL *) NULL) { + if (cent != (REAL *) nullptr) { cent[0] = pa[0] + rhs[0]; cent[1] = pa[1] + rhs[1]; cent[2] = pa[2] + rhs[2]; } - if (radius != (REAL *) NULL) { + if (radius != (REAL *) nullptr) { *radius = sqrt(rhs[0] * rhs[0] + rhs[1] * rhs[1] + rhs[2] * rhs[2]); } return true; @@ -7942,15 +7942,15 @@ void tetgenmesh::inscribedsphere(REAL* pa, REAL* pb, REAL* pc, REAL* pd, int i; // Get the all normals of the tet. - tetallnormal(pa, pb, pc, pd, N, NULL); + tetallnormal(pa, pb, pc, pd, N, nullptr); for (i = 0; i < 4; i++) { // H[i] is the inverse of height of its corresponding face. H[i] = sqrt(dot(N[i], N[i])); } // Compute the radius use eq. (1). rd = 1.0 / (H[0] + H[1] + H[2] + H[3]); - if (radius != (REAL*) NULL) *radius = rd; - if (cent != (REAL*) NULL) { + if (radius != (REAL*) nullptr) *radius = rd; + if (cent != (REAL*) nullptr) { // Compute the center use eq. (2). cent[0] = rd * (H[0] * pa[0] + H[1] * pb[0] + H[2] * pc[0] + H[3] * pd[0]); cent[1] = rd * (H[0] * pa[1] + H[1] * pb[1] + H[2] * pc[1] + H[3] * pd[1]); @@ -8240,7 +8240,7 @@ enum tetgenmesh::locateresult tetgenmesh::preciselocate(point searchpt, return OUTSIDE; } // Initialize the face for returning the walk-through face. - walkthroface.tet = (tetrahedron *) NULL; + walkthroface.tet = (tetrahedron *) nullptr; // Adjust the edge ring, so that 'ori1 < 0.0' holds. searchtet->ver = 0; // 'toppo' remains unchange for the following orientation tests. @@ -8404,7 +8404,7 @@ void tetgenmesh::randomsample(point searchpt, triface *searchtet) } tetptr = (tetrahedron *) (firsttet + (samplenum * tetrahedrons->itemwords)); - if (tetptr[4] != (tetrahedron) NULL) { + if (tetptr[4] != (tetrahedron) nullptr) { dist = distance2(tetptr, searchpt); if (dist < searchdist) { searchtet->tet = tetptr; @@ -8474,7 +8474,7 @@ enum tetgenmesh::locateresult tetgenmesh::locate2(point searchpt, return OUTSIDE; } - if (histtetarray != NULL) { + if (histtetarray != nullptr) { // Remember all the tets we've visited. assert(histtetarray->objects == 0l); infect(*searchtet); @@ -8712,7 +8712,7 @@ enum tetgenmesh::locateresult tetgenmesh::locate2(point searchpt, break; } - if (histtetarray != NULL) { + if (histtetarray != nullptr) { // Check if we have run into a loop. if (infected(*searchtet)) { // We have visited this tet. A potential loop is found. @@ -8734,7 +8734,7 @@ enum tetgenmesh::locateresult tetgenmesh::locate2(point searchpt, } // while (true) - if (histtetarray != NULL) { + if (histtetarray != nullptr) { // Unmark the visited tets. for (i = 0; i < (int) histtetarray->objects; i++) { parytet = (triface *) fastlookup(histtetarray, i); @@ -8932,7 +8932,7 @@ enum tetgenmesh::locateresult tetgenmesh::hullwalk(point searchpt, REAL ori; int i, j; - travtetlist = new list(sizeof(triface), NULL, 256); + travtetlist = new list(sizeof(triface), nullptr, 256); travtet = *hulltet; infect(travtet); travtetlist->append(&travtet); @@ -9399,7 +9399,7 @@ void tetgenmesh::enqueueflipface(triface& checkface, queue* flipqueue) sym(checkface, symface); if (symface.tet != dummytet) { - queface = (badface *) flipqueue->push((void *) NULL); + queface = (badface *) flipqueue->push((void *) nullptr); queface->tt = checkface; queface->foppo = oppo(symface); } @@ -9409,7 +9409,7 @@ void tetgenmesh::enqueueflipedge(face& checkedge, queue* flipqueue) { badface *queface; - queface = (badface *) flipqueue->push((void *) NULL); + queface = (badface *) flipqueue->push((void *) nullptr); queface->ss = checkedge; queface->forg = sorg(checkedge); queface->fdest = sdest(checkedge); @@ -9678,7 +9678,7 @@ void tetgenmesh::flip23(triface* flipface, queue* flipqueue) setpoint2tet(pd, encode(edab)); setpoint2tet(pe, encode(edab)); - if (flipqueue != (queue *) NULL) { + if (flipqueue != (queue *) nullptr) { enextfnext(edab, abdcasing); enqueueflipface(abdcasing, flipqueue); enext2fnext(edab, baecasing); @@ -9938,7 +9938,7 @@ void tetgenmesh::flip32(triface* flipface, queue* flipqueue) setpoint2tet(pd, encode(abcd)); setpoint2tet(pe, encode(bace)); - if (flipqueue != (queue *) NULL) { + if (flipqueue != (queue *) nullptr) { fnext(abcd, abdcasing); enqueueflipface(abdcasing, flipqueue); fnext(bace, baecasing); @@ -10356,7 +10356,7 @@ void tetgenmesh::flip22(triface* flipface, queue* flipqueue) // the rotation of tetrahedra. findedge(&abc, pa, pb); // Flip an edge of two subfaces, ignore non-Delaunay edges. - flip22sub(&abc, NULL); + flip22sub(&abc, nullptr); } if (b->verbose > 3) { @@ -10372,7 +10372,7 @@ void tetgenmesh::flip22(triface* flipface, queue* flipqueue) } } - if (flipqueue != (queue *) NULL) { + if (flipqueue != (queue *) nullptr) { enextfnext(abce, bcecasing); enqueueflipface(bcecasing, flipqueue); enext2fnext(abce, caecasing); @@ -10614,7 +10614,7 @@ void tetgenmesh::flip22sub(face* flipedge, queue* flipqueue) setpoint2sh(pc, sencode(bad)); setpoint2sh(pd, sencode(bad)); - if (flipqueue != (queue *) NULL) { + if (flipqueue != (queue *) nullptr) { enqueueflipedge(bccasout, flipqueue); enqueueflipedge(cacasout, flipqueue); enqueueflipedge(adcasout, flipqueue); @@ -10996,7 +10996,7 @@ long tetgenmesh::lawson(queue* flipqueue) if (lad * dot1 <= lac * dot2) { // angle1 is closer to 90 than angle2, choose abc (flipedge). abovepoint = facetabovepointarray[shellmark(flipedge)]; - if (abovepoint == (point) NULL) { + if (abovepoint == (point) nullptr) { getfacetabovepoint(&flipedge); } sign = insphere(pa, pb, pc, abovepoint, pd); @@ -11004,7 +11004,7 @@ long tetgenmesh::lawson(queue* flipqueue) } else { // angle2 is closer to 90 than angle1, choose abd (symedge). abovepoint = facetabovepointarray[shellmark(symedge)]; - if (abovepoint == (point) NULL) { + if (abovepoint == (point) nullptr) { getfacetabovepoint(&symedge); } sign = insphere(pa, pb, pd, abovepoint, pc); @@ -11121,7 +11121,7 @@ bool tetgenmesh::removetetbypeeloff(triface *striptet, triface *adjtetlist) } } // Do a 2-to-2 flip on abc and bad, transform abc->dca, bad->cdb. - flip22sub(&abc, NULL); + flip22sub(&abc, nullptr); // The two internal faces become boundary faces. tsbond(cdbcasing, bad); tsbond(dcacasing, abc); @@ -11174,12 +11174,12 @@ bool tetgenmesh::removeedgebyflip22(REAL *key, int n, triface *abtetlist, pf = apex(abtetlist[2]); } if (key && (*key > -1.0)) { - tetalldihedral(pc, pd, pe, pa, NULL, &d1, NULL); - tetalldihedral(pd, pc, pe, pb, NULL, &d2, NULL); + tetalldihedral(pc, pd, pe, pa, nullptr, &d1, nullptr); + tetalldihedral(pd, pc, pe, pb, nullptr, &d2, nullptr); cosmaxd = d1 < d2 ? d1 : d2; // Choose the bigger angle. if (n == 4) { - tetalldihedral(pd, pc, pf, pa, NULL, &d1, NULL); - tetalldihedral(pc, pd, pf, pb, NULL, &d2, NULL); + tetalldihedral(pd, pc, pf, pa, nullptr, &d1, nullptr); + tetalldihedral(pc, pd, pf, pb, nullptr, &d2, nullptr); d3 = d1 < d2 ? d1 : d2; // Choose the bigger angle. cosmaxd = cosmaxd < d3 ? cosmaxd : d3; // Choose the bigger angle. } @@ -11187,7 +11187,7 @@ bool tetgenmesh::removeedgebyflip22(REAL *key, int n, triface *abtetlist, } if (doflip) { - flip22(&abtetlist[0], NULL); + flip22(&abtetlist[0], nullptr); // Return the improved quality value. if (key) *key = cosmaxd; } @@ -11242,12 +11242,12 @@ bool tetgenmesh::removefacebyflip23(REAL *key, triface *abctetlist, } } doflip = (ori < 0.0); // Can abc be flipped away? - if (doflip && (key != (REAL *) NULL)) { + if (doflip && (key != (REAL *) nullptr)) { if (*key > -1.0) { // Test if the new tets reduce the maximal dihedral angle. - tetalldihedral(pe, pd, pa, pb, NULL, &d1, NULL); - tetalldihedral(pe, pd, pb, pc, NULL, &d2, NULL); - tetalldihedral(pe, pd, pc, pa, NULL, &d3, NULL); + tetalldihedral(pe, pd, pa, pb, nullptr, &d1, nullptr); + tetalldihedral(pe, pd, pb, pc, nullptr, &d2, nullptr); + tetalldihedral(pe, pd, pc, pa, nullptr, &d3, nullptr); cosmaxd = d1 < d2 ? d1 : d2; // Choose the bigger angle. cosmaxd = cosmaxd < d3 ? cosmaxd : d3; // Choose the bigger angle. doflip = (*key < cosmaxd); // Can local quality be improved? @@ -11308,7 +11308,7 @@ bool tetgenmesh::removefacebyflip23(REAL *key, triface *abctetlist, tsbond(newfront, checksh); } } - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { enqueueflipface(newfront, flipque); } enextself(abctetlist[0]); @@ -11325,7 +11325,7 @@ bool tetgenmesh::removefacebyflip23(REAL *key, triface *abctetlist, tsbond(newfront, checksh); } } - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { enqueueflipface(newfront, flipque); } enext2self(abctetlist[1]); @@ -11335,7 +11335,7 @@ bool tetgenmesh::removefacebyflip23(REAL *key, triface *abctetlist, // tetrahedrondealloc(abctetlist[i].tet); // } // Return the improved quality value. - if (key != (REAL *) NULL) *key = cosmaxd; + if (key != (REAL *) nullptr) *key = cosmaxd; return true; } @@ -11391,11 +11391,11 @@ bool tetgenmesh::removeedgebyflip32(REAL *key, triface *abtetlist, doflip = (ori < 0.0); // Can ab be flipped away? // Does the caller ensure a valid configuration? - if (doflip && (key != (REAL *) NULL)) { + if (doflip && (key != (REAL *) nullptr)) { if (*key > -1.0) { // Test if the new tets reduce the maximal dihedral angle. - tetalldihedral(pd, pc, pe, pa, NULL, &d1, NULL); - tetalldihedral(pc, pd, pe, pb, NULL, &d2, NULL); + tetalldihedral(pd, pc, pe, pa, nullptr, &d1, nullptr); + tetalldihedral(pc, pd, pe, pb, nullptr, &d2, nullptr); cosmaxd = d1 < d2 ? d1 : d2; // Choose the bigger angle. doflip = (*key < cosmaxd); // Can local quality be improved? // Return the key @@ -11404,7 +11404,7 @@ bool tetgenmesh::removeedgebyflip32(REAL *key, triface *abtetlist, } // Comment: This edge must not be fixed. It has been checked before. - if (doflip && (elemfliplist != NULL)) { + if (doflip && (elemfliplist != nullptr)) { // Regist this flip. if (!registerelemflip(T32, pa, pb, dummypoint, pc, pd, pe)) { // Detected a potential flip loop. Don't do it. @@ -11455,7 +11455,7 @@ bool tetgenmesh::removeedgebyflip32(REAL *key, triface *abtetlist, tsbond(newfront, checksh); } } - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { enqueueflipface(newfront, flipque); } enext2self(dcea); @@ -11473,7 +11473,7 @@ bool tetgenmesh::removeedgebyflip32(REAL *key, triface *abtetlist, tsbond(newfront, checksh); } } - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { enqueueflipface(newfront, flipque); } enextself(cdeb); @@ -11557,7 +11557,7 @@ bool tetgenmesh::removeedgebytranNM(REAL *key, int n, triface *abtetlist, p[j] = apex(abtetlist[(i + j) % n]); } // Is there a wanted edge? - if ((e1 != (point) NULL) && (e2 != (point) NULL)) { + if ((e1 != (point) nullptr) && (e2 != (point) nullptr)) { // Yes. Skip this face if p[1]<->p[n-1] is not the edge. if (!(((p[1] == e1) && (p[n - 1] == e2)) || ((p[1] == e2) && (p[n - 1] == e1)))) continue; @@ -11582,18 +11582,18 @@ bool tetgenmesh::removeedgebytranNM(REAL *key, int n, triface *abtetlist, // A valid (2-to-3) flip (or 4-to-4 flip) is found. copflag ? flip44s++ : flip23s++; doflip = true; - if (key != (REAL *) NULL) { + if (key != (REAL *) nullptr) { if (*key > -1.0) { // Test if the new tets reduce the maximal dihedral angle. Only 2 // tets, p_n-1.p_1.p_0.a and p_1.p_n-1.p_0.b, need to be tested // The left one a.b.p_n-1.p_1 goes into the new link of ab. - tetalldihedral(p[n - 1], p[1], p[0], pa, NULL, &d1, NULL); - tetalldihedral(p[1], p[n - 1], p[0], pb, NULL, &d2, NULL); + tetalldihedral(p[n - 1], p[1], p[0], pa, nullptr, &d1, nullptr); + tetalldihedral(p[1], p[n - 1], p[0], pb, nullptr, &d2, nullptr); cosmaxd = d1 < d2 ? d1 : d2; // Choose the bigger angle. doflip = *key < cosmaxd; // Can the local quality be improved? } } - if (doflip && (elemfliplist != NULL)) { + if (doflip && (elemfliplist != nullptr)) { // Comment: The flipping face must be not fixed. This case has been // tested during collecting the face ring of this edge. // Do not flip this face if it has been registered before. @@ -11602,7 +11602,7 @@ bool tetgenmesh::removeedgebytranNM(REAL *key, int n, triface *abtetlist, } } if (doflip) { - tmpkey = key != NULL ? *key : -1.0; + tmpkey = key != nullptr ? *key : -1.0; // Create the two new tets. maketetrahedron(&(newtetlist[0])); setorg(newtetlist[0], p[n - 1]); @@ -11686,7 +11686,7 @@ bool tetgenmesh::removeedgebytranNM(REAL *key, int n, triface *abtetlist, tsbond(newfront, checksh); } } - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { // Only queue the faces of the two new tets. if (j < 2) enqueueflipface(newfront, flipque); } @@ -11713,7 +11713,7 @@ bool tetgenmesh::removeedgebytranNM(REAL *key, int n, triface *abtetlist, tsbond(newfront, checksh); } } - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { // Only queue the faces of the two new tets. if (j < 2) enqueueflipface(newfront, flipque); } @@ -11725,7 +11725,7 @@ bool tetgenmesh::removeedgebytranNM(REAL *key, int n, triface *abtetlist, } if (n > 4) { success = removeedgebytranNM(&tmpkey, n-1, tmpabtetlist, - &(newtetlist[2]), NULL, NULL, flipque); + &(newtetlist[2]), nullptr, nullptr, flipque); } else { // assert(n == 4); success = removeedgebyflip32(&tmpkey, tmpabtetlist, &(newtetlist[2]), flipque); @@ -11741,13 +11741,13 @@ bool tetgenmesh::removeedgebytranNM(REAL *key, int n, triface *abtetlist, // tetrahedrondealloc(abtetlist[j].tet); // } // Save the minimal improved quality value. - if (key != (REAL *) NULL) { + if (key != (REAL *) nullptr) { *key = (tmpkey < cosmaxd ? tmpkey : cosmaxd); } return true; } else { // The new configuration is bad, substitue back the old tets. - if (elemfliplist != NULL) { + if (elemfliplist != nullptr) { // Remove the last registered 2-to-3 flip. elemfliplist->objects--; } @@ -11870,14 +11870,14 @@ bool tetgenmesh::removeedgebycombNM(REAL *key, int n, triface *abtetlist, } // Check if b.p_0 is of type N32 or N44. ori = orient3d(pb, p[0], p[1], p[n - 1]); - if ((ori > 0) && (key != (REAL *) NULL)) { + if ((ori > 0) && (key != (REAL *) nullptr)) { // b.p_0 is not N32. However, it is possible that the tet b.p_0.p_1. // p_n-1 has worse quality value than the key. In such case, also // try to flip b.p_0. - tetalldihedral(pb, p[0], p[n - 1], p[1], NULL, &tmpkey, NULL); + tetalldihedral(pb, p[0], p[n - 1], p[1], nullptr, &tmpkey, nullptr); if (tmpkey < *key) ori = 0.0; } - if ((fixededgelist != NULL) && (ori <= 0.0)) { + if ((fixededgelist != nullptr) && (ori <= 0.0)) { // b.p_0 is either N32 or N44. Do not flip a fixed edge. if (check4fixededge(pb, p[0])) { ori = 1.0; // Do not flip this edge. Skip it. @@ -11913,7 +11913,7 @@ bool tetgenmesh::removeedgebycombNM(REAL *key, int n, triface *abtetlist, if (doflip) { success = false; tmpkey = -1.0; // = acos(pi). - if (key != (REAL *) NULL) tmpkey = *key; + if (key != (REAL *) nullptr) tmpkey = *key; m = 0; if (*n1 == 3) { // Three tets case. Try flip32. @@ -12053,7 +12053,7 @@ bool tetgenmesh::removeedgebycombNM(REAL *key, int n, triface *abtetlist, } tmpkey2 = -1; if (key) tmpkey2 = *key; - if (elemfliplist != NULL) { + if (elemfliplist != nullptr) { // Remember the current registered flips. bakflipcount = elemfliplist->objects; } @@ -12062,7 +12062,7 @@ bool tetgenmesh::removeedgebycombNM(REAL *key, int n, triface *abtetlist, &(newtetlist[m - 1]), flipque); } else { // assert((n - 1) >= 4); success = removeedgebytranNM(&tmpkey2, n - 1, tmpabtetlist, - &(newtetlist[m - 1]), NULL, NULL, flipque); + &(newtetlist[m - 1]), nullptr, nullptr, flipque); } // No matter it was success or not, delete the temporary tets. for (j = 0; j < n - 1; j++) { @@ -12075,13 +12075,13 @@ bool tetgenmesh::removeedgebycombNM(REAL *key, int n, triface *abtetlist, // tetrahedrondealloc(abtetlist[j].tet); // } // Return the bigger dihedral in the two sets of new tets. - if (key != (REAL *) NULL) { + if (key != (REAL *) nullptr) { *key = tmpkey2 < tmpkey ? tmpkey2 : tmpkey; } return true; } else { // The new configuration is bad, substitue back the old tets. - if (elemfliplist != NULL) { + if (elemfliplist != nullptr) { // Restore the registered flips. elemfliplist->objects = bakflipcount; } @@ -12346,7 +12346,7 @@ void tetgenmesh::splittetrahedron(point newpoint, triface* splittet, printtet(&acdv); } - if (flipqueue != (queue *) NULL) { + if (flipqueue != (queue *) nullptr) { enqueueflipface(abcv, flipqueue); enqueueflipface(badv, flipqueue); enqueueflipface(cbdv, flipqueue); @@ -12404,7 +12404,7 @@ void tetgenmesh::splittetface(point newpoint, triface* splittet, pb = dest(abcd); pc = apex(abcd); pd = oppo(abcd); - pe = (point) NULL; // avoid a compile warning. + pe = (point) nullptr; // avoid a compile warning. // Is there a second tetrahderon? mirrorflag = issymexist(&abcd); if (mirrorflag) { @@ -12561,7 +12561,7 @@ void tetgenmesh::splittetface(point newpoint, triface* splittet, // Is there a subface needs to be split together? if (abcsh.sh != dummysh) { // Split this subface 'abc' into three i.e, abv, bcv, cav. - splitsubface(newpoint, &abcsh, (queue *) NULL); + splitsubface(newpoint, &abcsh, (queue *) nullptr); } } else if (checksubsegs) { // abvd.loc = abvd.ver = 0; @@ -12682,7 +12682,7 @@ void tetgenmesh::splittetface(point newpoint, triface* splittet, } } - if (flipqueue != (queue *) NULL) { + if (flipqueue != (queue *) nullptr) { fnextself(abvd); enqueueflipface(abvd, flipqueue); fnextself(bcvd); @@ -12890,7 +12890,7 @@ void tetgenmesh::splitsubface(point newpoint, face* splitface, printsh(&cav); } - if (flipqueue != (queue *) NULL) { + if (flipqueue != (queue *) nullptr) { enqueueflipedge(abv, flipqueue); enqueueflipedge(bcv, flipqueue); enqueueflipedge(cav, flipqueue); @@ -13171,7 +13171,7 @@ bool tetgenmesh::splittetedge(point newpoint, triface* splittet, if (splitsh.sh != dummysh) { // Split subfaces (and subsegment). findedge(&splitsh, pa, pb); - splitsubedge(newpoint, &splitsh, (queue *) NULL); + splitsubedge(newpoint, &splitsh, (queue *) nullptr); } } @@ -13184,7 +13184,7 @@ bool tetgenmesh::splittetedge(point newpoint, triface* splittet, } } - if (flipqueue != (queue *) NULL) { + if (flipqueue != (queue *) nullptr) { for (i = 0; i < wrapcount; i++) { enqueueflipface(bots[i], flipqueue); enqueueflipface(newtops[i], flipqueue); @@ -13501,7 +13501,7 @@ void tetgenmesh::splitsubedge(point newpoint, face* splitsh, queue* flipqueue) } while (spinabc.sh != startabc.sh); } - if (flipqueue != (queue *) NULL) { + if (flipqueue != (queue *) nullptr) { spinabc = startabc; do { // Adjust spinabc be edge av. @@ -13560,7 +13560,7 @@ void tetgenmesh::formstarpolyhedron(point pt, list* tetlist, list* verlist, // Add t into T. * (triface *)(* tetlist)[0] = starttet; infect(starttet); - if (verlist != (list *) NULL) { + if (verlist != (list *) nullptr) { // Add three verts of t into V. ver[0] = org(starttet); ver[1] = dest(starttet); @@ -13593,7 +13593,7 @@ void tetgenmesh::formstarpolyhedron(point pt, list* tetlist, list* verlist, // Add n into T. infect(neightet); tetlist->append(&neightet); - if (verlist != (list *) NULL) { + if (verlist != (list *) nullptr) { // Add the apex vertex in n into V. ver[0] = org(starttet); ver[1] = dest(starttet); @@ -13616,7 +13616,7 @@ void tetgenmesh::formstarpolyhedron(point pt, list* tetlist, list* verlist, starttet = * (triface *)(* tetlist)[i]; uninfect(starttet); } - if (verlist != (list *) NULL) { + if (verlist != (list *) nullptr) { // Uninfect vertices. for (i = 0; i < verlist->len(); i++) { ver[0] = * (point *)(* verlist)[i]; @@ -13702,7 +13702,7 @@ void tetgenmesh::formbowatcavitysub(point bp, face* bpseg, list* sublist, } } else { // Do not cross a segment. - if (bpseg != (face *) NULL) { + if (bpseg != (face *) nullptr) { if (checkseg.sh != bpseg->sh) { subceillist->append(&startsh); // Found an edge of C(p). } @@ -13891,7 +13891,7 @@ void tetgenmesh::formbowatcavity(point bp, face* bpseg, face* bpsh, int* n, int i, j; *n = 0; - if (bpseg != (face *) NULL) { + if (bpseg != (face *) nullptr) { // p is on segment S. bpseg->shver = 0; pa = sorg(*bpseg); @@ -13919,8 +13919,8 @@ void tetgenmesh::formbowatcavity(point bp, face* bpseg, face* bpsh, int* n, // Form CBC(p)s and C(p)s. spinsh = startsh; for (i = 0; i < *n; i++) { - sublists[i] = new list(sizeof(face), NULL, 256); - subceillists[i] = new list(sizeof(face), NULL, 256); + sublists[i] = new list(sizeof(face), nullptr, 256); + subceillists[i] = new list(sizeof(face), nullptr, 256); // Set a subface f to start search. startsh = spinsh; // Let f face to the quadrant of interest (used in forming BC(p)). @@ -13931,15 +13931,15 @@ void tetgenmesh::formbowatcavity(point bp, face* bpseg, face* bpsh, int* n, // Go to the next facet. spivotself(spinsh); } - } else if (sublists != (list **) NULL) { + } else if (sublists != (list **) nullptr) { // p is on a facet. *n = 2; // Form CBC(p) and C(p). - sublists[0] = new list(sizeof(face), NULL, 256); - subceillists[0] = new list(sizeof(face), NULL, 256); + sublists[0] = new list(sizeof(face), nullptr, 256); + subceillists[0] = new list(sizeof(face), nullptr, 256); sinfect(*bpsh); sublists[0]->append(bpsh); - formbowatcavitysub(bp, NULL, sublists[0], subceillists[0]); + formbowatcavitysub(bp, nullptr, sublists[0], subceillists[0]); } else { // p is inside a tet. *n = 1; @@ -13947,16 +13947,16 @@ void tetgenmesh::formbowatcavity(point bp, face* bpseg, face* bpsh, int* n, // Form BC_i(p) and B_i(p). for (i = 0; i < *n; i++) { - tetlists[i] = new list(sizeof(triface), NULL, 256); - ceillists[i] = new list(sizeof(triface), NULL, 256); - if (sublists != (list **) NULL) { + tetlists[i] = new list(sizeof(triface), nullptr, 256); + ceillists[i] = new list(sizeof(triface), nullptr, 256); + if (sublists != (list **) nullptr) { // There are C(p)s. - sublist = ((bpseg == (face *) NULL) ? sublists[0] : sublists[i]); + sublist = ((bpseg == (face *) nullptr) ? sublists[0] : sublists[i]); // Add all adjacent tets of C_i(p) into BC_i(p). for (j = 0; j < sublist->len(); j++) { startsh = * (face *)(* sublist)[j]; // Adjust the side facing to the right quadrant for C(p). - if ((bpseg == (face *) NULL) && (i == 1)) sesymself(startsh); + if ((bpseg == (face *) nullptr) && (i == 1)) sesymself(startsh); stpivot(startsh, adjtet); if (adjtet.tet != dummytet) { if (!infected(adjtet)) { @@ -13965,7 +13965,7 @@ void tetgenmesh::formbowatcavity(point bp, face* bpseg, face* bpsh, int* n, } } } - if (bpseg != (face *) NULL) { + if (bpseg != (face *) nullptr) { // The quadrant is bounded by another facet. sublist = ((i < *n - 1) ? sublists[i + 1] : sublists[0]); for (j = 0; j < sublist->len(); j++) { @@ -14007,7 +14007,7 @@ void tetgenmesh::releasebowatcavity(face* bpseg, int n, list** sublists, face oldsh; int i, j; - if (sublists != (list **) NULL) { + if (sublists != (list **) nullptr) { // Release CBC(p)s. for (i = 0; i < n; i++) { // Uninfect subfaces of CBC(p). @@ -14020,9 +14020,9 @@ void tetgenmesh::releasebowatcavity(face* bpseg, int n, list** sublists, } delete sublists[i]; delete subceillist[i]; - sublists[i] = (list *) NULL; - subceillist[i] = (list *) NULL; - if (bpseg == (face *) NULL) break; + sublists[i] = (list *) nullptr; + subceillist[i] = (list *) nullptr; + if (bpseg == (face *) nullptr) break; } } // Release BC(p). @@ -14037,8 +14037,8 @@ void tetgenmesh::releasebowatcavity(face* bpseg, int n, list** sublists, } delete tetlists[i]; delete ceillists[i]; - tetlists[i] = (list *) NULL; - ceillists[i] = (list *) NULL; + tetlists[i] = (list *) nullptr; + ceillists[i] = (list *) nullptr; } } @@ -14080,7 +14080,7 @@ bool tetgenmesh::validatebowatcavityquad(point bp,list* ceillist,REAL maxcosd) // If a non-trival 'maxcosd' is given. if (maxcosd > -1.0) { // Get the maximal dihedral angle of tet abcp. - tetalldihedral(pa, pb, pc, bp, NULL, &cosd, NULL); + tetalldihedral(pa, pb, pc, bp, nullptr, &cosd, nullptr); // Do not form the tet if the maximal dihedral angle is not reduced. if (cosd < maxcosd) { uninfect(ceiltet); @@ -14375,13 +14375,13 @@ bool tetgenmesh::trimbowatcavity(point bp, face* bpseg, int n, list** sublists, } cutnum += (oldnum - tetlists[i]->len()); } - if (valflag && (sublists != (list **) NULL)) { + if (valflag && (sublists != (list **) nullptr)) { // Validate CBC(p), C(p). cutcount = 0; for (i = 0; i < n; i++) { updatebowatcavitysub(sublists[i], subceillists[i], &cutcount); // Only do once if p is on a facet. - if (bpseg == (face *) NULL) break; + if (bpseg == (face *) nullptr) break; } // Are there cut tets? if (cutcount > 0) { @@ -14403,18 +14403,18 @@ bool tetgenmesh::trimbowatcavity(point bp, face* bpseg, int n, list** sublists, } while (true); // Check if any CBC(p) becomes non-empty. - if (valflag && (sublists != (list **) NULL)) { + if (valflag && (sublists != (list **) nullptr)) { for (i = 0; i < n && valflag; i++) { valflag = (sublists[i]->len() > 0); - if (bpseg == (face *) NULL) break; + if (bpseg == (face *) nullptr) break; } } if (valflag && (cutnum > 0)) { // Accumulate counters. - if (bpseg != (face *) NULL) { + if (bpseg != (face *) nullptr) { updsegcount++; - } else if (sublists != (list **) NULL) { + } else if (sublists != (list **) nullptr) { updsubcount++; } else { updvolcount++; @@ -14423,9 +14423,9 @@ bool tetgenmesh::trimbowatcavity(point bp, face* bpseg, int n, list** sublists, if (!valflag) { // Accumulate counters. - if (bpseg != (face *) NULL) { + if (bpseg != (face *) nullptr) { failsegcount++; - } else if (sublists != (list **) NULL) { + } else if (sublists != (list **) nullptr) { failsubcount++; } else { failvolcount++; @@ -14487,13 +14487,13 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, printf(" Insert point %d (%.12g, %.12g, %.12g)", pointmark(bp), bp[0], bp[1], bp[2]); } - if (splitseg != (face *) NULL) { + if (splitseg != (face *) nullptr) { if (b->verbose > 1) { printf(" on segment.\n"); } bowatsegcount++; } else { - if (subceillists != (list **) NULL) { + if (subceillists != (list **) nullptr) { if (b->verbose > 1) { printf(" on facet.\n"); } @@ -14545,7 +14545,7 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, if (checksh.sh != dummysh) { tsbond(newtet, checksh); } - if (verlist != (list *) NULL) { + if (verlist != (list *) nullptr) { // Collect vertices connecting to p. idx = pointmark(pa); if (idx >= 0) { @@ -14567,7 +14567,7 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, * (triface *)(* ceillist)[i] = newtet; } } - if (verlist != (list *) NULL) { + if (verlist != (list *) nullptr) { // Uninfect collected vertices. for (i = 0; i < verlist->len(); i++) { pa = * (point *)(* verlist)[i]; @@ -14616,7 +14616,7 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, // Bond the two tets together. bond(newface, rotface); // Queue (uniquely) this face if 'flipque' is given. - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { enqueueflipface(newface, flipque); } } @@ -14626,9 +14626,9 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, } } - if (subceillists != (list **) NULL) { + if (subceillists != (list **) nullptr) { // There are C(p)s. - if (splitseg != (face *) NULL) { + if (splitseg != (face *) nullptr) { // S (ab) is split by p. splitseg->shver = 0; pa = sorg(*splitseg); @@ -14762,7 +14762,7 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, senext2(newsh, newedge); // edge pc. sesymself(newedge); // edge cp. } - if (splitseg != (face *) NULL) { + if (splitseg != (face *) nullptr) { // Don not operate on newedge if it is ap or pb. if (sorg(newedge) == pa) { apsegshs[k] = newedge; @@ -14793,10 +14793,10 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, } } // Only do once if p is on a facet. - if (splitseg == (face *) NULL) break; + if (splitseg == (face *) nullptr) break; } // for (k = 0; k < n; k++) - if (splitseg != (face *) NULL) { + if (splitseg != (face *) nullptr) { // Update a->b to be a->p. apseg = *splitseg; setsdest(apseg, bp); @@ -14863,8 +14863,8 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, // Check for newly encroached subsegments if the flag is set. if (chkencseg) { // Check if a->p and p->b are encroached by other vertices. - checkseg4encroach(&apseg, NULL, NULL, true); - checkseg4encroach(&pbseg, NULL, NULL, true); + checkseg4encroach(&apseg, nullptr, nullptr, true); + checkseg4encroach(&pbseg, nullptr, nullptr, true); // Check if the adjacent segments are encroached by p. tallencsegs(bp, n, ceillists); } @@ -14880,7 +14880,7 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, // routine releasebowatcavity() which only frees the memory. sublists[k]->clear(); // Only do once if p is on a facet. - if (splitseg == (face *) NULL) break; + if (splitseg == (face *) nullptr) break; } // Check for newly encroached subfaces if the flag is set. @@ -14890,10 +14890,10 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, subceillist = subceillists[k]; for (i = 0; i < subceillist->len(); i++) { newsh = * (face *)(* subceillist)[i]; - checksub4encroach(&newsh, NULL, true); + checksub4encroach(&newsh, nullptr, true); } // Only do once if p is on a facet. - if (splitseg == (face *) NULL) break; + if (splitseg == (face *) nullptr) break; } // Check if the adjacent subfaces are encroached by p. tallencsubs(bp, n, ceillists); @@ -14922,7 +14922,7 @@ void tetgenmesh::bowatinsertsite(point bp,face* splitseg,int n,list** sublists, } } - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { // Newly created internal faces of BC(p) (excluding faces on C(p)s) are // in 'flipque'. Some of these faces may be locally non-Delaunay due // to the existence of non-constrained tets. check and fix them. @@ -15124,7 +15124,7 @@ void tetgenmesh::btree_search(point insertpt, triface* searchtet) arylen = (long) ptary[0]; if (arylen == 0) { - searchtet->tet = NULL; + searchtet->tet = nullptr; return; } @@ -15141,7 +15141,7 @@ void tetgenmesh::btree_search(point insertpt, triface* searchtet) // Select "good" candidate using k random samples, taking the closest one. mindist2 = 1.79769E+308; // The largest double value (8 byte). - nearpt = NULL; + nearpt = nullptr; for (i = 0; i < ptsamples; i++) { ptidx = randomnation((unsigned long) arylen); @@ -15201,7 +15201,7 @@ void tetgenmesh::ordervertices(point* vertexarray, int arraysize) index++; } // Clear this tree node. - ptary[0] = (point) 0; + ptary[0] = (point) nullptr; // Swap i-th node to j-th node. swappptary = *ipptary; *ipptary = *jpptary; // [i] <= [j] @@ -15261,7 +15261,7 @@ enum tetgenmesh::locateresult tetgenmesh::insertvertexbw(point insertpt, updatecount = 0; // Locate the point. - if (searchtet->tet == NULL) { + if (searchtet->tet == nullptr) { if (btreenode_list) { // default option // Use bsp-tree to select a starting tetrahedron. btree_search(insertpt, searchtet); @@ -15272,7 +15272,7 @@ enum tetgenmesh::locateresult tetgenmesh::insertvertexbw(point insertpt, loc = preciselocate(insertpt, searchtet, tetrahedrons->items); } else { // Start from 'searchtet'. - loc = locate2(insertpt, searchtet, NULL); + loc = locate2(insertpt, searchtet, nullptr); } if (b->verbose > 1) { @@ -15818,7 +15818,7 @@ enum tetgenmesh::locateresult tetgenmesh::insertvertexbw(point insertpt, // mark the other three faces of this tet as "open". neightet.tet = newtet.tet; for (j = 0; j < 3; j++) { - neightet.tet[locpivot[0][j]] = NULL; + neightet.tet[locpivot[0][j]] = nullptr; } // Let the oldtet knows newtet (for connecting adjacent new tets). parytet->tet[parytet->loc] = encode(newtet); @@ -15864,7 +15864,7 @@ enum tetgenmesh::locateresult tetgenmesh::insertvertexbw(point insertpt, // assert((newtet.ver & 1) == 0); // in CCW edge ring. for (j = 0; j < 3; j++) { fnext(newtet, neightet); // Go to the "open" face. - if (neightet.tet[neightet.loc] == NULL) { + if (neightet.tet[neightet.loc] == nullptr) { spintet = *parytet; while (1) { fnextself(spintet); @@ -15875,7 +15875,7 @@ enum tetgenmesh::locateresult tetgenmesh::insertvertexbw(point insertpt, if (spintet.tet != dummytet) { // 'spintet' is the adjacent tet of the cavity. fnext(spintet, neineitet); - assert(neineitet.tet[neineitet.loc] == NULL); // SELF_CHECK + assert(neineitet.tet[neineitet.loc] == nullptr); // SELF_CHECK bond(neightet, neineitet); } else { // This side is a hull face. @@ -16109,7 +16109,7 @@ bool tetgenmesh::incrflipdelaunay(triface* oldtet, point* insertarray, setdest(newtet, insertarray[1]); setapex(newtet, insertarray[2]); setoppo(newtet, lastpt); - if (oldtet != (triface *) NULL) { + if (oldtet != (triface *) nullptr) { for (j = 0; j < in->numberoftetrahedronattributes; j++) { attrib = elemattribute(oldtet->tet, j); setelemattribute(newtet.tet, j, attrib); @@ -16154,7 +16154,7 @@ bool tetgenmesh::incrflipdelaunay(triface* oldtet, point* insertarray, // Insert the rest of points, one by one. for (; i < arraysize; i++) { if (jump) { - searchtet.tet = NULL; + searchtet.tet = nullptr; } else { searchtet = recenttet; } @@ -16191,7 +16191,7 @@ long tetgenmesh::delaunizevertices() max_btree_depth = 0; } - if (cavetetlist == NULL) { + if (cavetetlist == nullptr) { cavetetlist = new arraypool(sizeof(triface), 10); cavebdrylist = new arraypool(sizeof(triface), 10); caveoldtetlist = new arraypool(sizeof(triface), 10); @@ -16237,8 +16237,8 @@ long tetgenmesh::delaunizevertices() } // Form the DT by incremental flip Delaunay algorithm. - success = incrflipdelaunay(NULL, insertarray, arraysize, true, b->plc, - 0.0, NULL); + success = incrflipdelaunay(nullptr, insertarray, arraysize, true, b->plc, + 0.0, nullptr); if (b->btree) { point **pptary; @@ -16247,7 +16247,7 @@ long tetgenmesh::delaunizevertices() delete [] *pptary; } delete btreenode_list; - btreenode_list = NULL; + btreenode_list = nullptr; } delete [] insertarray; @@ -16295,7 +16295,7 @@ enum tetgenmesh::locateresult tetgenmesh::sinsertvertex(point insertpt, REAL sign, ori, area; int n, s, i, j; - if (splitseg != NULL) { + if (splitseg != nullptr) { spivot(*splitseg, *splitsh); loc = ONEDGE; } else { @@ -16312,7 +16312,7 @@ enum tetgenmesh::locateresult tetgenmesh::sinsertvertex(point insertpt, } if (loc == ONEDGE) { - if (splitseg == NULL) { + if (splitseg == nullptr) { // Do not split a segment. sspivot(*splitsh, checkseg); if (checkseg.sh != dummysh) return loc; // return ONSUBSEG; @@ -16334,7 +16334,7 @@ enum tetgenmesh::locateresult tetgenmesh::sinsertvertex(point insertpt, } // Does 'insertpt' lie on a segment? - if (splitseg != NULL) { + if (splitseg != nullptr) { splitseg->shver = 0; pa = sorg(*splitseg); // Count the number of faces at segment [a, b]. @@ -16360,7 +16360,7 @@ enum tetgenmesh::locateresult tetgenmesh::sinsertvertex(point insertpt, smarktest(*splitsh); caveshlist->newindex((void **) &parysh); *parysh = *splitsh; - if (splitseg != NULL) { + if (splitseg != nullptr) { for (i = 1; i < n; i++) { smarktest(abfaces[i]); caveshlist->newindex((void **) &parysh); @@ -16624,7 +16624,7 @@ enum tetgenmesh::locateresult tetgenmesh::sinsertvertex(point insertpt, } } - if (splitseg != NULL) { + if (splitseg != nullptr) { // Split the segment [a, b]. aseg = *splitseg; pa = sorg(aseg); @@ -16638,7 +16638,7 @@ enum tetgenmesh::locateresult tetgenmesh::sinsertvertex(point insertpt, // setshvertices(bseg, insertpt, pb, NULL); setsorg(bseg, insertpt); setsdest(bseg, pb); - setsapex(bseg, NULL); + setsapex(bseg, nullptr); setsdest(aseg, insertpt); setshellmark(bseg, shellmark(aseg)); // This is done outside this routine (at where newpt was created). @@ -16818,7 +16818,7 @@ void tetgenmesh::formstarpolygon(point pt, list* trilist, list* vertlist) * (face *)(* trilist)[0] = steinsh; pa = sorg(steinsh); pb = sdest(steinsh); - if (vertlist != (list *) NULL) { + if (vertlist != (list *) nullptr) { // Add two verts a, b into V, vertlist->append(&pa); vertlist->append(&pb); @@ -16844,7 +16844,7 @@ void tetgenmesh::formstarpolygon(point pt, list* trilist, list* vertlist) // Add edge ca to E. pc = sorg(lnextsh); if (pc == pb) break; // Rotate back. - if (vertlist != (list *) NULL) { + if (vertlist != (list *) nullptr) { // Add vert c into V. vertlist->append(&pc); } @@ -16870,7 +16870,7 @@ void tetgenmesh::formstarpolygon(point pt, list* trilist, list* vertlist) // Add edge bd to E. pd = sdest(rnextsh); if (pd == pa) break; // Rotate back. - if (vertlist != (list *) NULL) { + if (vertlist != (list *) nullptr) { // Add vert d into V. vertlist->append(&pd); } @@ -16921,9 +16921,9 @@ void tetgenmesh::getfacetabovepoint(face* facetsh) abovecount++; // Initialize working lists. - verlist = new list(sizeof(point *), NULL); - trilist = new list(sizeof(face), NULL); - tetlist = new list(sizeof(triface), NULL); + verlist = new list(sizeof(point *), nullptr); + trilist = new list(sizeof(face), nullptr); + tetlist = new list(sizeof(triface), nullptr); // Get three pivotal points p1, p2, and p3 in the facet as a base triangle // which is non-trivil and has good base angle (close to 90 degree). @@ -17131,7 +17131,7 @@ bool tetgenmesh::incrflipdelaunaysub(int shmark, REAL eps, list* ptlist, } // Are there area constraints? - if (b->quality && (in->facetconstraintlist != (REAL *) NULL)) { + if (b->quality && (in->facetconstraintlist != (REAL *) nullptr)) { idx = in->facetmarkerlist[shmark - 1]; // The actual facet marker. for (k = 0; k < in->numberoffacetconstraints; k++) { fmarker = (int) in->facetconstraintlist[k * 2]; @@ -17160,7 +17160,7 @@ bool tetgenmesh::incrflipdelaunaysub(int shmark, REAL eps, list* ptlist, if (aboveflag) { // Compute the 'abovepoint' for orient3d(). abovepoint = facetabovepointarray[shmark]; - if (abovepoint == (point) NULL) { + if (abovepoint == (point) nullptr) { getfacetabovepoint(&newsh); } } @@ -17179,7 +17179,7 @@ bool tetgenmesh::incrflipdelaunaysub(int shmark, REAL eps, list* ptlist, for (; i < arraysize; i++) { // Insert p_i. startsh.sh = dummysh; - loc = sinsertvertex(insertarray[i], &startsh, NULL, true, true); + loc = sinsertvertex(insertarray[i], &startsh, nullptr, true, true); // The point-to-subface map has been updated. // Set p_i's type FREESUBVERTEX if it has no type yet. if (pointtype(insertarray[i]) == FREEVOLVERTEX) { @@ -17318,7 +17318,7 @@ void tetgenmesh::insertsubseg(face* tri) setsorg(newsubseg, pa); setsdest(newsubseg, pb); // Are there length constraints? - if (b->quality && (in->segmentconstraintlist != (REAL *) NULL)) { + if (b->quality && (in->segmentconstraintlist != (REAL *) nullptr)) { for (i = 0; i < in->numberofsegmentconstraints; i++) { e1 = (int) in->segmentconstraintlist[i * 3]; e2 = (int) in->segmentconstraintlist[i * 3 + 1]; @@ -17607,7 +17607,7 @@ void tetgenmesh::plaguesub(memorypool* viri) // their neighbors, then to their neighbors' neighbors. viri->traversalinit(); virusloop = (shellface **) viri->traverse(); - while (virusloop != (shellface **) NULL) { + while (virusloop != (shellface **) nullptr) { testtri.sh = *virusloop; // Check each of the triangle's three neighbors. for (i = 0; i < 3; i++) { @@ -17654,7 +17654,7 @@ void tetgenmesh::plaguesub(memorypool* viri) ghostsh.sh = dummysh; // A handle of outer space. viri->traversalinit(); virusloop = (shellface **) viri->traverse(); - while (virusloop != (shellface **) NULL) { + while (virusloop != (shellface **) nullptr) { testtri.sh = *virusloop; // Record changes in the number of boundary edges, and disconnect // dead triangles from their neighbors. @@ -17888,12 +17888,12 @@ void tetgenmesh::unifysegments() // Compute a mapping from indices of vertices to subfaces. makesubfacemap(idx2facelist, facesperverlist); // Initialize 'sfacelist' for constructing the face link of each segment. - sfacelist = new list(sizeof(face), NULL); + sfacelist = new list(sizeof(face), nullptr); segmarker = 1; subsegs->traversalinit(); subsegloop.sh = shellfacetraverse(subsegs); - while (subsegloop.sh != (shellface *) NULL) { + while (subsegloop.sh != (shellface *) nullptr) { subsegloop.shver = 0; // For sure. torg = sorg(subsegloop); tdest = sdest(subsegloop); @@ -18001,7 +18001,7 @@ void tetgenmesh::assignsegmentmarkers() printf(" Assigning segment markers.\n"); } - assert(in->edgemarkerlist != NULL); + assert(in->edgemarkerlist != nullptr); makesegmentmap(idx2seglist, segsperverlist); for (i = 0; i < in->numberofedges; i++) { @@ -18063,7 +18063,7 @@ void tetgenmesh::mergefacets(queue* flipqueue) // Loop the segments, counter the number of segments sharing each vertex. subsegs->traversalinit(); segloop.sh = shellfacetraverse(subsegs); - while (segloop.sh != (shellface *) NULL) { + while (segloop.sh != (shellface *) nullptr) { // Increment the number of sharing segments for each endpoint. for (i = 0; i < 2; i++) { j = pointmark((point) segloop.sh[3 + i]); @@ -18075,7 +18075,7 @@ void tetgenmesh::mergefacets(queue* flipqueue) // Loop the segments, find out dead segments. subsegs->traversalinit(); segloop.sh = shellfacetraverse(subsegs); - while (segloop.sh != (shellface *) NULL) { + while (segloop.sh != (shellface *) nullptr) { eorg = sorg(segloop); edest = sdest(segloop); spivot(segloop, parentsh); @@ -18105,7 +18105,7 @@ void tetgenmesh::mergefacets(queue* flipqueue) } } if (ori == 0.0) { - mergeflag = (in->facetmarkerlist == (int *) NULL || + mergeflag = (in->facetmarkerlist == (int *) nullptr || in->facetmarkerlist[fidx1] == in->facetmarkerlist[fidx2]); if (mergeflag) { // This segment becomes dead. @@ -18189,7 +18189,7 @@ long tetgenmesh::meshsurface() // Initialize 'facetabovepointarray'. facetabovepointarray = new point[in->numberoffacets + 1]; for (i = 0; i < in->numberoffacets + 1; i++) { - facetabovepointarray[i] = (point) NULL; + facetabovepointarray[i] = (point) nullptr; } if (checkpbcs) { // Initialize the global array 'subpbcgrouptable'. @@ -18199,8 +18199,8 @@ long tetgenmesh::meshsurface() // Initialize working lists. viri = new memorypool(sizeof(shellface *), 1024, POINTER, 0); flipqueue = new queue(sizeof(badface)); - ptlist = new list(sizeof(point *), NULL, 256); - conlist = new list(sizeof(point *) * 2, NULL, 256); + ptlist = new list(sizeof(point *), nullptr, 256); + conlist = new list(sizeof(point *) * 2, nullptr, 256); worklist = new int[points->items + 1]; for (i = 0; i < points->items + 1; i++) worklist[i] = 0; @@ -18280,7 +18280,7 @@ long tetgenmesh::meshsurface() worklist[end2] = 1; } // Save the segment in S (conlist). - cons = (point *) conlist->append(NULL); + cons = (point *) conlist->append(nullptr); cons[0] = tstart; cons[1] = tend; // Set the start for next continuous segment. @@ -18322,8 +18322,8 @@ long tetgenmesh::meshsurface() delete caveshlist; delete caveshbdlist; - caveshlist = NULL; - caveshbdlist = NULL; + caveshlist = nullptr; + caveshbdlist = nullptr; // Unify segments in 'subsegs', remove redundant segments. Face links // of segments are also built. @@ -18411,11 +18411,11 @@ interecursive(shellface** subfacearray, int arraysize, int axis, REAL bxmin, } leftarray = new shellface*[arraysize]; - if (leftarray == NULL) { + if (leftarray == nullptr) { terminatetetgen(1); } rightarray = new shellface*[arraysize]; - if (rightarray == NULL) { + if (rightarray == nullptr) { terminatetetgen(1); } leftsize = rightsize = 0; @@ -18576,7 +18576,7 @@ void tetgenmesh::detectinterfaces() subfaces->traversalinit(); shloop.sh = shellfacetraverse(subfaces); i = 0; - while (shloop.sh != (shellface *) NULL) { + while (shloop.sh != (shellface *) nullptr) { subfacearray[i] = shloop.sh; shloop.sh = shellfacetraverse(subfaces); i++; @@ -18603,7 +18603,7 @@ void tetgenmesh::detectinterfaces() // After this loop, only intersecting faces remain. subfaces->traversalinit(); shloop.sh = shellfacetraverse(subfaces); - while (shloop.sh != (shellface *) NULL) { + while (shloop.sh != (shellface *) nullptr) { if (sinfected(shloop)) { suninfect(shloop); } else { @@ -18667,7 +18667,7 @@ void tetgenmesh::markacutevertices(REAL acuteangle) // Loop over the set of vertices. points->traversalinit(); pointloop = pointtraverse(); - while (pointloop != (point) NULL) { + while (pointloop != (point) nullptr) { idx = pointmark(pointloop) - in->firstnumber; // Only do test if p is an endpoint of some segments. if (idx2seglist[idx + 1] > idx2seglist[idx]) { @@ -18937,7 +18937,7 @@ enum tetgenmesh::interresult tetgenmesh::finddirection2(triface* searchtet, REAL hori, rori, lori; REAL dmin, dist; - assert((searchtet->tet != NULL) && (searchtet->tet != dummytet)); + assert((searchtet->tet != nullptr) && (searchtet->tet != dummytet)); // The origin is fixed. pa = org(*searchtet); @@ -19283,7 +19283,7 @@ enum tetgenmesh::interresult tetgenmesh::finddirection3(triface* searchtet, pb = dest(oppoface); pc = apex(oppoface); // Check if face [a, b, c] intersects the searching path. - if (tri_edge_test(pa, pb, pc, startpt, endpt, NULL, 1, types, poss)) { + if (tri_edge_test(pa, pb, pc, startpt, endpt, nullptr, 1, types, poss)) { // They intersect. Get the type of intersection. dir = (enum interresult) types[0]; pos = poss[0]; @@ -19394,7 +19394,7 @@ enum tetgenmesh::interresult tetgenmesh::scoutsegment2(face* sseg, int pos, i; // Is 'searchtet' a valid handle? - if ((searchtet->tet == NULL) || (searchtet->tet == dummytet)) { + if ((searchtet->tet == nullptr) || (searchtet->tet == dummytet)) { startpt = sorg(*sseg); point2tetorg(startpt, *searchtet); } else { @@ -19452,10 +19452,10 @@ enum tetgenmesh::interresult tetgenmesh::scoutsegment2(face* sseg, symedgeself(*searchtet); // Enter the adjacent tet. pa = org(*searchtet); - angmax = interiorangle(pa, startpt, endpt, NULL); + angmax = interiorangle(pa, startpt, endpt, nullptr); *refpt = pa; pb = dest(*searchtet); - ang = interiorangle(pb, startpt, endpt, NULL); + ang = interiorangle(pb, startpt, endpt, nullptr); if (ang > angmax) { angmax = ang; *refpt = pb; @@ -19478,7 +19478,7 @@ enum tetgenmesh::interresult tetgenmesh::scoutsegment2(face* sseg, } pc = apex(*searchtet); - ang = interiorangle(pc, startpt, endpt, NULL); + ang = interiorangle(pc, startpt, endpt, nullptr); if (ang > angmax) { angmax = ang; *refpt = pc; @@ -19499,7 +19499,7 @@ enum tetgenmesh::interresult tetgenmesh::scoutsegment2(face* sseg, // Stop if we meet 'endpt'. if (pd == endpt) break; - ang = interiorangle(pd, startpt, endpt, NULL); + ang = interiorangle(pd, startpt, endpt, nullptr); if (ang > angmax) { angmax = ang; *refpt = pd; @@ -19561,7 +19561,7 @@ enum tetgenmesh::interresult tetgenmesh::scoutsegment2(face* sseg, } pd = org(neightet); if (b->verbose > 2) { - angmax = interiorangle(pd, startpt, endpt, NULL); + angmax = interiorangle(pd, startpt, endpt, nullptr); } *refpt = pd; break; @@ -19789,7 +19789,7 @@ void tetgenmesh::delaunizesegments2() suninfect(sseg); // Insert the segment. - searchtet.tet = NULL; + searchtet.tet = nullptr; dir = scoutsegment2(&sseg, &searchtet, &refpt); if (dir != SHAREEDGE) { @@ -19859,7 +19859,7 @@ enum tetgenmesh::interresult tetgenmesh::scoutsubface(face* pssub, int hitbdry; int i; - if ((searchtet->tet == NULL) || (searchtet->tet == dummytet)) { + if ((searchtet->tet == nullptr) || (searchtet->tet == dummytet)) { // Search an edge of 'ssub' in tetrahedralization. pssub->shver = 0; for (i = 0; i < 3; i++) { @@ -20002,7 +20002,7 @@ enum tetgenmesh::interresult tetgenmesh::scoutcrosstet(face *pssub, int hitbdry; int i; - if (facpoints != NULL) { + if (facpoints != nullptr) { // Infect all vertices of the facet. for (i = 0; i < (int) facpoints->objects; i++) { pd = * (point *) fastlookup(facpoints, i); @@ -20113,8 +20113,8 @@ enum tetgenmesh::interresult tetgenmesh::scoutcrosstet(face *pssub, // AND (ii) a, b, c, d has the closet circumradius of [a, b, c]. // NOTE: (ii) is needed since there may be several points satisfy (i). // For an example, see file2.poly. - circumsphere(pa, pb, pc, NULL, n, &r); - crossface.tet = NULL; + circumsphere(pa, pb, pc, nullptr, n, &r); + crossface.tet = nullptr; pe = apex(*searchtet); spintet = *searchtet; hitbdry = 0; @@ -20128,7 +20128,7 @@ enum tetgenmesh::interresult tetgenmesh::scoutcrosstet(face *pssub, if (pinfected(pd)) { len = DIST(n, pd); dr = fabs(len - r); - if (crossface.tet == NULL) { + if (crossface.tet == nullptr) { // This is the first cross face. crossface = spintet; drmin = dr; @@ -20161,8 +20161,8 @@ enum tetgenmesh::interresult tetgenmesh::scoutcrosstet(face *pssub, break; } } - if(crossface.tet == NULL) { - assert(crossface.tet != NULL); // Not handled yet. + if(crossface.tet == nullptr) { + assert(crossface.tet != nullptr); // Not handled yet. } *searchtet = crossface; dummypoint[0] = dummypoint[1] = dummypoint[2] = 0; @@ -20174,7 +20174,7 @@ enum tetgenmesh::interresult tetgenmesh::scoutcrosstet(face *pssub, pointmark(pa), pointmark(pb), pointmark(apex(*searchtet)), pointmark(oppo(*searchtet))); } - if (facpoints != NULL) { + if (facpoints != nullptr) { // Unmark all facet vertices. for (i = 0; i < (int) facpoints->objects; i++) { pd = * (point *) fastlookup(facpoints, i); @@ -20288,7 +20288,7 @@ void tetgenmesh::recoversubfacebyflips(face* pssub, triface* crossface, // flipfaces[1] refers to edge [b, c] (either b->c or c->b). } - flip22sub(&(flipfaces[0]), NULL); + flip22sub(&(flipfaces[0]), nullptr); flip22count++; // Comment: now flipfaces[0] is [d, a, b], flipfaces[1] is [a, d, c]. @@ -20464,7 +20464,7 @@ void tetgenmesh::formcavity(face *pssub, arraypool* crosstets, pb = sdest(*parysh); pc = sapex(*parysh); // Check if pd->pf crosses the facet. - if (tri_edge_test(pa, pb, pc, pd, pf, NULL, 1, types, poss)) { + if (tri_edge_test(pa, pb, pc, pd, pf, nullptr, 1, types, poss)) { dir = (enum interresult) types[0]; if ((dir == INTEREDGE) || (dir == INTERFACE)) { // The edge d->f corsses the facet. @@ -20475,7 +20475,7 @@ void tetgenmesh::formcavity(face *pssub, arraypool* crosstets, } } // Check if pe->pf crosses the facet. - if (tri_edge_test(pa, pb, pc, pe, pf, NULL, 1, types, poss)) { + if (tri_edge_test(pa, pb, pc, pe, pf, nullptr, 1, types, poss)) { dir = (enum interresult) types[0]; if ((dir == INTEREDGE) || (dir == INTERFACE)) { // The edge f->e crosses the face. @@ -20862,7 +20862,7 @@ bool tetgenmesh::delaunizecavity(arraypool *cavpoints, arraypool *cavfaces, pinfect(pa); pinfect(pb); pinfect(pc); - pd = NULL; + pd = nullptr; for (i = 1; i < (int) cavfaces->objects; i++) { parytet = (triface *) fastlookup(cavfaces, i); pt[0] = org(*parytet); @@ -20882,7 +20882,7 @@ bool tetgenmesh::delaunizecavity(arraypool *cavpoints, arraypool *cavfaces, } // } } - if (pd != NULL) break; + if (pd != nullptr) break; } assert(i < (int) cavfaces->objects); // SELF_CHECK pinfect(pd); @@ -20946,7 +20946,7 @@ bool tetgenmesh::delaunizecavity(arraypool *cavpoints, arraypool *cavfaces, setsapex(tmpsh, pt[2]); // Comment: This side of tmpsh faces to the outside of the cavity. // Insert tmpsh in DT. - searchtet.tet = NULL; + searchtet.tet = nullptr; dir = scoutsubface(&tmpsh, &searchtet, 1); if (dir == SHAREFACE) { // Let tmpsh face to the interior tet of the cavity. @@ -21174,7 +21174,7 @@ bool tetgenmesh::fillcavity(arraypool* topshells, arraypool* botshells, // Connect newtets to tets outside the cavity. for (k = 0; k < 2; k++) { cavshells = (k == 0 ? topshells : botshells); - if (cavshells != NULL) { + if (cavshells != nullptr) { for (i = 0; i < (int) cavshells->objects; i++) { // Get a temp subface. parysh = (face *) fastlookup(cavshells, i); @@ -21258,7 +21258,7 @@ bool tetgenmesh::fillcavity(arraypool* topshells, arraypool* botshells, mflag = true; // Initialize it. - if (midfaces != NULL) { + if (midfaces != nullptr) { // Mark all facet vertices for finding middle subfaces. for (i = 0; i < (int) facpoints->objects; i++) { @@ -21410,7 +21410,7 @@ bool tetgenmesh::fillcavity(arraypool* topshells, arraypool* botshells, } // if (midfaces != NULL) if (mflag) { - if (midfaces != NULL) { + if (midfaces != nullptr) { if (b->verbose > 1) { printf(" Found %ld middle subfaces.\n", midfaces->objects); } @@ -21488,7 +21488,7 @@ bool tetgenmesh::fillcavity(arraypool* topshells, arraypool* botshells, ndelaunayedgecount++; } - if (facpoints != NULL) { + if (facpoints != nullptr) { // Unmark all facet vertices. for (i = 0; i < (int) facpoints->objects; i++) { pf = * (point *) fastlookup(facpoints, i); @@ -21499,7 +21499,7 @@ bool tetgenmesh::fillcavity(arraypool* topshells, arraypool* botshells, // Delete the temp subfaces and faked tets. for (k = 0; k < 2; k++) { cavshells = (k == 0 ? topshells : botshells); - if (cavshells != NULL) { + if (cavshells != nullptr) { for (i = 0; i < (int) cavshells->objects; i++) { parysh = (face *) fastlookup(cavshells, i); decode(parysh->sh[0], bdrytet); @@ -21526,10 +21526,10 @@ bool tetgenmesh::fillcavity(arraypool* topshells, arraypool* botshells, } topshells->restart(); - if (botshells != NULL) { + if (botshells != nullptr) { botshells->restart(); } - if (midfaces != NULL) { + if (midfaces != nullptr) { midfaces->restart(); } // Comment: Now no vertex is marked. @@ -21604,7 +21604,7 @@ void tetgenmesh::carvecavity(arraypool *crosstets, arraypool *topnewtets, // Collect infected new tets in cavity. for (k = 0; k < 2; k++) { newtets = (k == 0 ? topnewtets : botnewtets); - if (newtets != NULL) { + if (newtets != nullptr) { for (i = 0; i < (int) newtets->objects; i++) { parytet = (triface *) fastlookup(newtets, i); if (infected(*parytet)) { @@ -21637,7 +21637,7 @@ void tetgenmesh::carvecavity(arraypool *crosstets, arraypool *topnewtets, // Delete outer new tets (those new tets which are not infected). for (k = 0; k < 2; k++) { newtets = (k == 0 ? topnewtets : botnewtets); - if (newtets != NULL) { + if (newtets != nullptr) { for (i = 0; i < (int) newtets->objects; i++) { parytet = (triface *) fastlookup(newtets, i); if (infected(*parytet)) { @@ -21654,7 +21654,7 @@ void tetgenmesh::carvecavity(arraypool *crosstets, arraypool *topnewtets, crosstets->restart(); topnewtets->restart(); - if (botnewtets != NULL) { + if (botnewtets != nullptr) { botnewtets->restart(); } } @@ -21716,7 +21716,7 @@ void tetgenmesh::restorecavity(arraypool *crosstets, arraypool *topnewtets, tetrahedrondealloc(parytet->tet); } - if (botnewtets != NULL) { + if (botnewtets != nullptr) { for (i = 0; i < (int) botnewtets->objects; i++) { parytet = (triface *) fastlookup(botnewtets, i); tetrahedrondealloc(parytet->tet); @@ -21725,7 +21725,7 @@ void tetgenmesh::restorecavity(arraypool *crosstets, arraypool *topnewtets, crosstets->restart(); topnewtets->restart(); - if (botnewtets != NULL) { + if (botnewtets != nullptr) { botnewtets->restart(); } } @@ -21798,11 +21798,11 @@ void tetgenmesh::splitsubedge(point newpt, face *searchsh, arraypool *facfaces, */ // Set the abovepoint of f for point location. abovepoint = facetabovepointarray[shellmark(*searchsh)]; - if (abovepoint == (point) NULL) { + if (abovepoint == (point) nullptr) { getfacetabovepoint(searchsh); } // Insert the new point on facet. New subfaces are queued for reocvery. - loc = sinsertvertex(newpt, searchsh, NULL, true, false); + loc = sinsertvertex(newpt, searchsh, nullptr, true, false); if (loc == OUTSIDE) { assert(0); // Not handled yet. } @@ -21861,7 +21861,7 @@ void tetgenmesh::constrainedfacets2() pssub = (face *) fastlookup(subfacstack, subfacstack->objects); ssub = *pssub; - if (ssub.sh[3] == NULL) continue; // Skip a dead subface. + if (ssub.sh[3] == nullptr) continue; // Skip a dead subface. stpivot(ssub, neightet); if (neightet.tet == dummytet) { @@ -21937,7 +21937,7 @@ void tetgenmesh::constrainedfacets2() if (neightet.tet != dummytet) continue; // Not a missing subface. // Insert the subface. - searchtet.tet = NULL; + searchtet.tet = nullptr; dir = scoutsubface(&ssub, &searchtet, 1); if (dir == SHAREFACE) continue; // The subface is inserted. assert(dir != COLLISIONFACE); // SELF_CHECK @@ -22136,20 +22136,20 @@ void tetgenmesh::formskeleton(clock_t& tv) delete caveshlist; delete caveshbdlist; - caveshlist = NULL; - caveshbdlist = NULL; + caveshlist = nullptr; + caveshbdlist = nullptr; // Detach all segments from tets. tetrahedrons->traversalinit(); searchtet.tet = tetrahedrontraverse(); - while (searchtet.tet != (tetrahedron *) NULL) { - if (searchtet.tet[8] != NULL) { + while (searchtet.tet != (tetrahedron *) nullptr) { + if (searchtet.tet[8] != nullptr) { for (i = 0; i < 6; i++) { searchtet.loc = edge2locver[i][0]; searchtet.ver = edge2locver[i][1]; tssdissolve1(searchtet); } - searchtet.tet[8] = NULL; + searchtet.tet[8] = nullptr; } searchtet.tet = tetrahedrontraverse(); } @@ -22181,7 +22181,7 @@ void tetgenmesh::infecthull(memorypool *viri) } tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Is this tetrahedron on the hull? for (tetloop.loc = 0; tetloop.loc < 4; tetloop.loc++) { sym(tetloop, tsymtet); @@ -22252,7 +22252,7 @@ void tetgenmesh::plague(memorypool *viri) // their neighbors, then to their neighbors' neighbors. viri->traversalinit(); virusloop = (tetrahedron **) viri->traverse(); - while (virusloop != (tetrahedron **) NULL) { + while (virusloop != (tetrahedron **) nullptr) { testtet.tet = *virusloop; // Temporarily uninfect this tetrahedron, not necessary. uninfect(testtet); @@ -22379,7 +22379,7 @@ regionplague(memorypool *regionviri, REAL attribute, REAL volume) // neighbors. regionviri->traversalinit(); virusloop = (tetrahedron **) regionviri->traverse(); - while (virusloop != (tetrahedron **) NULL) { + while (virusloop != (tetrahedron **) nullptr) { testtet.tet = *virusloop; // Temporarily uninfect this tetrahedron, not necessary. uninfect(testtet); @@ -22422,7 +22422,7 @@ regionplague(memorypool *regionviri, REAL attribute, REAL volume) } regionviri->traversalinit(); virusloop = (tetrahedron **) regionviri->traverse(); - while (virusloop != (tetrahedron **) NULL) { + while (virusloop != (tetrahedron **) nullptr) { testtet.tet = *virusloop; uninfect(testtet); virusloop = (tetrahedron **) regionviri->traverse(); @@ -22456,7 +22456,7 @@ void tetgenmesh::removeholetets(memorypool* viri) // Loop the tetrahedra list, counter the number of tets sharing each node. tetrahedrons->traversalinit(); testtet.tet = tetrahedrontraverse(); - while (testtet.tet != (tetrahedron *) NULL) { + while (testtet.tet != (tetrahedron *) nullptr) { // Increment the number of sharing tets for each endpoint. for (i = 0; i < 4; i++) { j = pointmark((point) testtet.tet[4 + i]); @@ -22467,7 +22467,7 @@ void tetgenmesh::removeholetets(memorypool* viri) viri->traversalinit(); virusloop = (tetrahedron **) viri->traverse(); - while (virusloop != (tetrahedron **) NULL) { + while (virusloop != (tetrahedron **) nullptr) { testtet.tet = *virusloop; // Record changes in the number of boundary faces, and disconnect // dead tetrahedra from their neighbors. @@ -22534,15 +22534,15 @@ void tetgenmesh::assignregionattribs() printf(" Assign region numbers.\n"); } - regionnumlist = new list(sizeof(int), NULL, 256); - regiontetlist = new list(sizeof(triface), NULL, 1024); + regionnumlist = new list(sizeof(int), nullptr, 256); + regiontetlist = new list(sizeof(triface), nullptr, 1024); attridx = in->numberoftetrahedronattributes; // Loop through all tets. Infect tets which already have a region number, // and save the used numbers in 'regionnumlist'. tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { if (!infected(tetloop)) { regionnum = (int) elemattribute(tetloop.tet, attridx); if (regionnum != 0.0) { @@ -22592,7 +22592,7 @@ void tetgenmesh::assignregionattribs() tetloop.tet = tetrahedrontraverse(); regionnum = 1; // Start region number. count = 0; - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { if (!infected(tetloop)) { // An unassigned region tet. count++; @@ -22638,7 +22638,7 @@ void tetgenmesh::assignregionattribs() // Uninfect all tets. tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { #ifdef SELF_CHECK assert(infected(tetloop)); #endif @@ -22725,7 +22725,7 @@ void tetgenmesh::carveholes() // Assign every tetrahedron a regional attribute of zero. tetrahedrons->traversalinit(); tptr = tetrahedrontraverse(); - while (tptr != (tetrahedron *) NULL) { + while (tptr != (tetrahedron *) nullptr) { setelemattribute(tptr, in->numberoftetrahedronattributes, 0.0); tptr = tetrahedrontraverse(); } @@ -22882,7 +22882,7 @@ void tetgenmesh::initializecavity(list* floorlist, list* ceillist, setorg(faketet, sorg(worksh)); setdest(faketet, sdest(worksh)); setapex(faketet, sapex(worksh)); - setoppo(faketet, (point) NULL); // Indicates it is 'fake'. + setoppo(faketet, (point) nullptr); // Indicates it is 'fake'. tsbond(faketet, worksh); frontlist->append(&faketet); } else { @@ -22908,7 +22908,7 @@ void tetgenmesh::initializecavity(list* floorlist, list* ceillist, setorg(faketet, org(neightet)); setdest(faketet, dest(neightet)); setapex(faketet, apex(neightet)); - setoppo(faketet, (point) NULL); // Indicates it is 'fake'. + setoppo(faketet, (point) nullptr); // Indicates it is 'fake'. // Bond t' to a subface if it exists. tspivot(neightet, worksh); if (worksh.sh != dummysh) { @@ -22958,14 +22958,14 @@ bool tetgenmesh::delaunizecavvertices(triface* oldtet, list* floorptlist, // Prepare the array of points for inserting. arraysize = floorptlist->len(); - if (ceilptlist != (list *) NULL) { + if (ceilptlist != (list *) nullptr) { arraysize += ceilptlist->len(); } insertarray = new point[arraysize]; for (i = 0; i < floorptlist->len(); i++) { insertarray[i] = * (point *)(* floorptlist)[i]; } - if (ceilptlist != (list *) NULL) { + if (ceilptlist != (list *) nullptr) { for (j = 0; j < ceilptlist->len(); j++) { insertarray[i + j] = * (point *)(* ceilptlist)[j]; } @@ -23201,9 +23201,9 @@ void tetgenmesh::gluefronts(triface* front, triface* front1, list* gluetetlist, } } // Does f hold by a fake tet. - if (oppo(*front) == (point) NULL) { + if (oppo(*front) == (point) nullptr) { // f is fake. Case (3) or (4). - assert(oppo(*front1) != (point) NULL); // Eliminate (4). + assert(oppo(*front1) != (point) nullptr); // Eliminate (4). // Case (3). if (consh.sh != dummysh) { stdissolve(consh); // Dissolve: c -x-> f. @@ -23223,9 +23223,9 @@ void tetgenmesh::gluefronts(triface* front, triface* front1, list* gluetetlist, // No. Check for case (2). tspivot(*front1, consh); // Is f1 fake? - if (oppo(*front1) == (point) NULL) { + if (oppo(*front1) == (point) nullptr) { // Case (2) or (4) - assert(oppo(*front) != (point) NULL); // Eliminate (4). + assert(oppo(*front) != (point) nullptr); // Eliminate (4). // Case (2). if (consh.sh != dummysh) { stdissolve(consh); // Dissolve: c -x-> f1. @@ -23374,7 +23374,7 @@ void tetgenmesh::detachauxsubfaces(list* newtetlist) tspivot(newtet, auxsh); if (auxsh.sh != dummysh) { // An auxilary subface s. - assert(sorg(auxsh) == (point) NULL); + assert(sorg(auxsh) == (point) nullptr); tsdissolve(newtet); // t -x-> s. sym(newtet, neightet); if (neightet.tet != dummytet) { @@ -23604,7 +23604,7 @@ bool tetgenmesh::carvecavity(list* newtetlist, list* outtetlist, pointptr = apex(front); setpoint2tet(pointptr, encode(newtet)); // Does f hold by a fake tet. - if (oppo(front) == (point) NULL) { + if (oppo(front) == (point) nullptr) { // f is fake. if (consh.sh != dummysh) { sesymself(consh); @@ -23628,7 +23628,7 @@ bool tetgenmesh::carvecavity(list* newtetlist, list* outtetlist, bond(newtet, front); } // t may be non-locally Delaunay and flipable. - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { enqueueflipface(newtet, flipque); } } @@ -23974,10 +23974,10 @@ bool tetgenmesh::removeedgebyflips(triface* remedge, int *flipcount) // 2 < n < 20. if (n == 3) { // There are three tets at ab. Try to do a flip32 at ab. - remflag = removeedgebyflip32(NULL, abtetlist, newtetlist, NULL); + remflag = removeedgebyflip32(nullptr, abtetlist, newtetlist, nullptr); } else if ((n > 3) && (n <= b->maxflipedgelinksize)) { // Four tets case. Try to do edge transformation. - remflag = removeedgebytranNM(NULL,n,abtetlist,newtetlist,NULL,NULL,NULL); + remflag = removeedgebytranNM(nullptr,n,abtetlist,newtetlist,nullptr,nullptr,nullptr); } else { if (b->verbose > 1) { printf(" !! Unhandled case: n = %d.\n", n); @@ -24009,8 +24009,8 @@ bool tetgenmesh::removeedgebyflips(triface* remedge, int *flipcount) if (n <= b->maxflipedgelinksize) { // Try to do a combination of flips. n1 = 0; - remflag = removeedgebycombNM(NULL, n, abtetlist, &n1, bftetlist, - newtetlist, NULL); + remflag = removeedgebycombNM(nullptr, n, abtetlist, &n1, bftetlist, + newtetlist, nullptr); if (remflag) { // Delete the old tets. for (i = 0; i < n; i++) { @@ -24104,7 +24104,7 @@ bool tetgenmesh::removefacebyflips(triface* remface, int *flipcount) return false; } // Do a 2-to-3 flip. - flip23(remface, NULL); + flip23(remface, nullptr); *flipcount = *flipcount + 1; return true; } @@ -24123,7 +24123,7 @@ bool tetgenmesh::removefacebyflips(triface* remface, int *flipcount) symself(checkface2); if ((checkface1.tet == dummytet) && (checkface2.tet == dummytet)) { // Check if the edge [a, b] intersects [d, e] in its interior. - if (tri_edge_test(pa, pb, pc, pd, pe, NULL, 1, types, poss)) { + if (tri_edge_test(pa, pb, pc, pd, pe, nullptr, 1, types, poss)) { dir = (enum interresult) types[0]; if (dir == INTEREDGE) { // Edge [d, e] intersects [a, b, c]. A flip 2-to-2 is found. @@ -24139,7 +24139,7 @@ bool tetgenmesh::removefacebyflips(triface* remface, int *flipcount) return false; } // We can flip this edge [a, b]. - flip22(remface, NULL); + flip22(remface, nullptr); *flipcount = *flipcount + 1; return true; } else { @@ -24342,14 +24342,14 @@ bool tetgenmesh::recoverfacebyflips(triface* front, int *flipcount) // does, we try to flip the face [b, d, e] away. // Search a crossing edge/face and try to flip it away. - remedge.tet = remface.tet = NULL; + remedge.tet = remface.tet = nullptr; spintet = searchtet; hitbdry = 0; do { pd = apex(spintet); pe = oppo(spintet); // Check if edge [d, e] intersects [a, b, c]. - if (tri_edge_test(pa, pb, pc, pd, pe, NULL, 0, NULL, NULL)) { + if (tri_edge_test(pa, pb, pc, pd, pe, nullptr, 0, nullptr, nullptr)) { remedge = spintet; enextfnextself(remedge); enextself(remedge); // Edge [pd->pe]. @@ -24357,7 +24357,7 @@ bool tetgenmesh::recoverfacebyflips(triface* front, int *flipcount) } // Check if [b, c] intersects [a, d, e]. if (!iscollinear(pa, pd, pe, b->epsilon)) { - if (tri_edge_test(pa, pd, pe, pb, pc, NULL, 0, NULL, NULL)) { + if (tri_edge_test(pa, pd, pe, pb, pc, nullptr, 0, nullptr, nullptr)) { remface = spintet; enext2fnextself(remface); // Face [a, d, e]. break; @@ -24365,7 +24365,7 @@ bool tetgenmesh::recoverfacebyflips(triface* front, int *flipcount) } if (!iscollinear(pb, pd, pe, b->epsilon)) { // Check if [a, c] intersects [b, d, e]. - if (tri_edge_test(pb, pd, pe, pa, pc, NULL, 0, NULL, NULL)) { + if (tri_edge_test(pb, pd, pe, pa, pc, nullptr, 0, nullptr, nullptr)) { remface = spintet; enextfnextself(remface); // Face [b, d, e]. break; @@ -24378,10 +24378,10 @@ bool tetgenmesh::recoverfacebyflips(triface* front, int *flipcount) if (apex(spintet) == apex(searchtet)) break; } while (hitbdry < 2); - if (remedge.tet != NULL) { + if (remedge.tet != nullptr) { // Try to remove this crossing edge. success = removeedgebyflips(&remedge, flipcount); - } else if (remface.tet != NULL) { + } else if (remface.tet != nullptr) { /*// Do not flip it if it is a subface. tspivot(remface, checksh); if (checksh.sh != dummysh) { @@ -24438,7 +24438,7 @@ bool tetgenmesh::constrainedcavity(triface* oldtet, list* floorlist, // Initialize the cavity C. initializecavity(floorlist, ceillist, frontlist, ptlist, glueshlist); // Form the D of the vertices of C. - success = delaunizecavvertices(oldtet, ptlist, NULL, newtetlist, flipque); + success = delaunizecavvertices(oldtet, ptlist, nullptr, newtetlist, flipque); if (success) { // Identify faces of C in D. @@ -24476,7 +24476,7 @@ bool tetgenmesh::constrainedcavity(triface* oldtet, list* floorlist, // All fronts have identified in D. Get the shape of C by removing out // tets of C. 'misfrontlist' is reused for removing out tets. // Don't do flip since the new tets may get deleted later. - if (carvecavity(newtetlist, misfrontlist, gluetetlist, NULL)) { + if (carvecavity(newtetlist, misfrontlist, gluetetlist, nullptr)) { return true; } } @@ -24552,7 +24552,7 @@ bool tetgenmesh::findrelocatepoint2(point steinpt, point relocatept, pa = org(oldtet); pb = dest(oldtet); pc = apex(oldtet); - if (tri_edge_test(pa, pb, pc, steinpt, farpt, farpt, 0, NULL, NULL)) { + if (tri_edge_test(pa, pb, pc, steinpt, farpt, farpt, 0, nullptr, nullptr)) { // projpt2face(steinpt, pa, pb, pc, fcent); // Find the intersected face. Calculate the intersection. planelineint(pa, pb, pc, steinpt, farpt, fcent, &factor); @@ -24670,7 +24670,7 @@ bool tetgenmesh::relocatepoint(point steinpt, triface* oldtet, list* frontlist, setdest(newtet, dest(front)); setapex(newtet, apex(front)); setoppo(newtet, steinpt); - if (oldtet != (triface *) NULL) { + if (oldtet != (triface *) nullptr) { for (j = 0; j < in->numberoftetrahedronattributes; j++) { attrib = elemattribute(oldtet->tet, j); setelemattribute(newtet.tet, j, attrib); @@ -24690,7 +24690,7 @@ bool tetgenmesh::relocatepoint(point steinpt, triface* oldtet, list* frontlist, setpoint2tet(steinpt, encode(newtet)); // 'front' may be a 'fake' tet. tspivot(front, checksh); - if (oppo(front) == (point) NULL) { + if (oppo(front) == (point) nullptr) { if (checksh.sh != dummysh) { stdissolve(checksh); } @@ -24716,7 +24716,7 @@ bool tetgenmesh::relocatepoint(point steinpt, triface* oldtet, list* frontlist, sesymself(checksh); tsbond(newtet, checksh); } - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { // f may be non-locally Delaunay and flipable. enqueueflipface(newtet, flipque); } @@ -24772,7 +24772,7 @@ bool tetgenmesh::relocatepoint(point steinpt, triface* oldtet, list* frontlist, return false; } - if (flipque != (queue *) NULL) { + if (flipque != (queue *) nullptr) { // Recover locally Delaunay faces. lawson3d(flipque); } @@ -24879,7 +24879,7 @@ bool tetgenmesh::findcollapseedge(point suppt, point *conpt, list* oldtetlist, if (ltmp == 0.0) { // No edge can be collapseed. - *conpt = (point) NULL; + *conpt = (point) nullptr; return false; } else { pt = * (point *)(* ptlist)[itmp]; @@ -24982,7 +24982,7 @@ void tetgenmesh::deallocfaketets(list* frontlist) adjustedgering(front, CW); sym(front, neightet); tspivot(front, checksh); - if (oppo(front) == (point) NULL) { + if (oppo(front) == (point) nullptr) { if (b->verbose > 2) { printf(" Get fake tet (%d, %d, %d).\n", pointmark(org(front)), pointmark(dest(front)), pointmark(apex(front))); @@ -25109,14 +25109,14 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, // Initialize working lists, variables. for (i = 0; i < 2; i++) { - oldtetlist[i] = (list *) NULL; - newtetlist[i] = (list *) NULL; - newpt[i] = (point) NULL; - } - gluetetlist = new list(sizeof(triface), NULL, 256); - glueshlist = new list(sizeof(face), NULL, 256); - oldshlist = new list(sizeof(face), NULL, 256); - newshlist = new list(sizeof(face), NULL, 256); + oldtetlist[i] = (list *) nullptr; + newtetlist[i] = (list *) nullptr; + newpt[i] = (point) nullptr; + } + gluetetlist = new list(sizeof(triface), nullptr, 256); + glueshlist = new list(sizeof(face), nullptr, 256); + oldshlist = new list(sizeof(face), nullptr, 256); + newshlist = new list(sizeof(face), nullptr, 256); success = true; // Assume p can be suppressed. bakchecksubfaces = checksubfaces; @@ -25128,13 +25128,13 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, // Get the edges of C(p). They form a closed polygon. for (i = 0; i < oldshlist->len(); i++) { oldsh = * (face *)(* oldshlist)[i]; - cons = (point *) conlist->append(NULL); + cons = (point *) conlist->append(nullptr); cons[0] = sorg(oldsh); cons[1] = sdest(oldsh); } // Re-triangulate the old C(p). shmark = shellmark(*supsh); - triangulate(shmark, b->epsilon, ptlist, conlist, 0, NULL, viri, flipque); + triangulate(shmark, b->epsilon, ptlist, conlist, 0, nullptr, viri, flipque); // Get new subs of C(p), remove protected segments. retrievenewsubs(newshlist, true); // Substitute the old C(p) with the new C(p) @@ -25156,8 +25156,8 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, // Is this part empty? if (oldtet.tet == dummytet) continue; // Allocate spaces for storing (old and new) B_i(p). - oldtetlist[i] = new list(sizeof(triface), NULL, 256); - newtetlist[i] = new list(sizeof(triface), NULL, 256); + oldtetlist[i] = new list(sizeof(triface), nullptr, 256); + newtetlist[i] = new list(sizeof(triface), nullptr, 256); // Form old B_i(p) in oldtetlist[i]. assert(!isdead(&oldtet)); oldtetlist[i]->append(&oldtet); @@ -25187,14 +25187,14 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, if (success) { // p is relocated by newpt[i]. Now insert it. Don't do flip since // the new tets may get deleted again. - relocatepoint(newpt[i], &oldtet, frontlist, newtetlist[i], NULL); + relocatepoint(newpt[i], &oldtet, frontlist, newtetlist[i], nullptr); setpointtype(newpt[i], FREEVOLVERTEX); relverts++; } else { // Fail to relocate p. Clean fake tets and quit this option. deallocfaketets(frontlist); pointdealloc(newpt[i]); - newpt[i] = (point) NULL; + newpt[i] = (point) nullptr; assert(newtetlist[i]->len() == 0); } } @@ -25236,7 +25236,7 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, } // Delete old B_i(p). for (i = 0; i < 2; i++) { - if (oldtetlist[i] != (list *) NULL) { + if (oldtetlist[i] != (list *) nullptr) { // Delete tets of the old B_i(p). for (j = 0; j < oldtetlist[i]->len(); j++) { oldtet = * (triface *)(* (oldtetlist[i]))[j]; @@ -25248,7 +25248,7 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, if (optflag) { // Check for new bad-quality tets. for (i = 0; i < 2; i++) { - if (newtetlist[i] != (list *) NULL) { + if (newtetlist[i] != (list *) nullptr) { for (j = 0; j < newtetlist[i]->len(); j++) { newtet = * (triface *)(* (newtetlist[i]))[j]; if (!isdead(&newtet)) checktet4opt(&newtet, true); @@ -25260,7 +25260,7 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, for (i = 0; i < glueshlist->len(); i++) { newsh = * (face *)(* glueshlist)[i]; // Insert it into mesh (it may be already inserted). - newtet.tet = NULL; + newtet.tet = nullptr; // The mesh may be non-convex (set convexflag = 0). dir = scoutsubface(&newsh, &newtet, 0); if (dir != SHAREFACE) { @@ -25291,7 +25291,7 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, } // Restore old B_i(p). for (i = 0; i < 2; i++) { - if (oldtetlist[i] != (list *) NULL) { + if (oldtetlist[i] != (list *) nullptr) { // Uninfect tets of old B_i(p). for (j = 0; j < oldtetlist[i]->len(); j++) { oldtet = * (triface *)(* (oldtetlist[i]))[j]; @@ -25312,7 +25312,7 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, } // } // Dealloc newpt[i] if it exists. - if (newpt[i] != (point) NULL) { + if (newpt[i] != (point) nullptr) { pointdealloc(newpt[i]); relverts--; } @@ -25346,7 +25346,7 @@ bool tetgenmesh::suppressfacetpoint(face* supsh, list* frontlist, delete oldshlist; delete newshlist; for (i = 0; i < 2; i++) { - if (oldtetlist[i] != (list *) NULL) { + if (oldtetlist[i] != (list *) nullptr) { delete oldtetlist[i]; delete newtetlist[i]; } @@ -25494,14 +25494,14 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, newshlist = new list*[n]; newpt = new point[n]; for (i = 0; i < n; i++) { - oldtetlist[i] = (list *) NULL; - newtetlist[i] = (list *) NULL; - oldshlist[i] = (list *) NULL; - newshlist[i] = (list *) NULL; - newpt[i] = (point) NULL; + oldtetlist[i] = (list *) nullptr; + newtetlist[i] = (list *) nullptr; + oldshlist[i] = (list *) nullptr; + newshlist[i] = (list *) nullptr; + newpt[i] = (point) nullptr; } - gluetetlist = new list(sizeof(triface), NULL, 256); - glueshlist = new list(sizeof(face), NULL, 256); + gluetetlist = new list(sizeof(triface), nullptr, 256); + glueshlist = new list(sizeof(face), nullptr, 256); // Create a new segment ab (result in newseg). makeshellface(subsegs, &newseg); @@ -25546,25 +25546,25 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, for (i = 0; i < spinshlist->len(); i++) { spinsh = * (face *)(* spinshlist)[i]; // Allocate spaces for C_i(p). - oldshlist[i] = new list(sizeof(face), NULL, 256); - newshlist[i] = new list(sizeof(face), NULL, 256); + oldshlist[i] = new list(sizeof(face), nullptr, 256); + newshlist[i] = new list(sizeof(face), nullptr, 256); // Get the subs of C_i(p). oldshlist[i]->append(&spinsh); formstarpolygon(suppt, oldshlist[i], ptlist); // Find the edges of C_i(p). It DOES NOT form a closed polygon. for (j = 0; j < oldshlist[i]->len(); j++) { oldsh = * (face *)(* (oldshlist[i]))[j]; - cons = (point *) conlist->append(NULL); + cons = (point *) conlist->append(nullptr); cons[0] = sorg(oldsh); cons[1] = sdest(oldsh); } // The C_i(p) isn't closed without ab. Add it to it. - cons = (point *) conlist->append(NULL); + cons = (point *) conlist->append(nullptr); cons[0] = pa; cons[1] = pb; // Re-triangulate C_i(p). shmark = shellmark(spinsh); - triangulate(shmark, b->epsilon, ptlist, conlist, 0, NULL, viri, flipque); + triangulate(shmark, b->epsilon, ptlist, conlist, 0, nullptr, viri, flipque); // Get new subs of C_i(p), remove protected segments. retrievenewsubs(newshlist[i], true); // Substitute old C_i(p) with the new C_i(p). !IT IS NOT COMPLETE! @@ -25604,7 +25604,7 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, checksubfaces = bakchecksubfaces; // A work list for keeping subfaces from two facets. - dnewshlist = new list(sizeof(face), NULL, 256); + dnewshlist = new list(sizeof(face), nullptr, 256); success = true; // Assume p is suppressable. // Suppress p in all B(p). B_i(p) is looped wrt the right-hand rule of ab. @@ -25620,8 +25620,8 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, // Is B_i(p) empty? if (oldtet.tet == dummytet) continue; // Allocate spaces for B_i(p). - oldtetlist[i] = new list(sizeof(triface), NULL, 256); - newtetlist[i] = new list(sizeof(triface), NULL, 256); + oldtetlist[i] = new list(sizeof(triface), nullptr, 256); + newtetlist[i] = new list(sizeof(triface), nullptr, 256); // Find all tets of old B_i(p). oldtetlist[i]->append(&oldtet); formstarpolyhedron(suppt, oldtetlist[i], ptlist, false); @@ -25683,13 +25683,13 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, if (success) { // p is relocated by newpt[i]. Now insert it. Don't do flip since // the new tets may get deleted again. - if (relocatepoint(newpt[i], &oldtet, frontlist, newtetlist[i], NULL)) { + if (relocatepoint(newpt[i], &oldtet, frontlist, newtetlist[i], nullptr)) { setpointtype(newpt[i], FREEVOLVERTEX); relverts++; } else { // The faked tets are deleted in above route. pointdealloc(newpt[i]); - newpt[i] = (point) NULL; + newpt[i] = (point) nullptr; newtetlist[i]->clear(); success = false; } @@ -25697,7 +25697,7 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, // Fail to relocate p. Clean fake tets and quit this option. deallocfaketets(frontlist); pointdealloc(newpt[i]); - newpt[i] = (point) NULL; + newpt[i] = (point) nullptr; assert(newtetlist[i]->len() == 0); } } @@ -25749,7 +25749,7 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, // Delete tets old B_i(p). for (i = 0; i < spinshlist->len(); i++) { // Delete them if it is not empty. - if (oldtetlist[i] != (list *) NULL) { + if (oldtetlist[i] != (list *) nullptr) { for (j = 0; j < oldtetlist[i]->len(); j++) { oldtet = * (triface *)(* (oldtetlist[i]))[j]; assert(!isdead(&oldtet)); @@ -25760,7 +25760,7 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, if (optflag) { for (i = 0; i < spinshlist->len(); i++) { // Check for new bad-quality tets. - if (newtetlist[i] != (list *) NULL) { + if (newtetlist[i] != (list *) nullptr) { for (j = 0; j < newtetlist[i]->len(); j++) { newtet = * (triface *)(* (newtetlist[i]))[j]; if (!isdead(&newtet)) checktet4opt(&newtet, true); @@ -25772,7 +25772,7 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, for (i = 0; i < glueshlist->len(); i++) { newsh = * (face *)(* glueshlist)[i]; // Insert it into mesh (it may be already inserted). - newtet.tet = NULL; + newtet.tet = nullptr; // The mesh may be non-convex (set convexflag = 0). dir = scoutsubface(&newsh, &newtet, 0); if (dir != SHAREFACE) { @@ -25837,7 +25837,7 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, } // Restore old B_i(p). for (i = 0; i < spinshlist->len(); i++) { - if (oldtetlist[i] != (list *) NULL) { + if (oldtetlist[i] != (list *) nullptr) { // Uninfect tets of old B_i(p). for (j = 0; j < oldtetlist[i]->len(); j++) { oldtet = * (triface *)(* (oldtetlist[i]))[j]; @@ -25858,7 +25858,7 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, } // } // Dealloc newpt[i] if it exists. - if (newpt[i] != (point) NULL) { + if (newpt[i] != (point) nullptr) { pointdealloc(newpt[i]); relverts--; } @@ -25900,7 +25900,7 @@ bool tetgenmesh::suppresssegpoint(face* supseg, list* spinshlist, delete [] oldshlist; delete [] newshlist; for (i = 0; i < spinshlist->len(); i++) { - if (oldtetlist[i] != (list *) NULL) { + if (oldtetlist[i] != (list *) nullptr) { delete oldtetlist[i]; delete newtetlist[i]; } @@ -25943,20 +25943,20 @@ bool tetgenmesh::suppressvolpoint(triface* suptet, list* frontlist, int j, k; // Allocate spaces for storing (old and new) B(p). - oldtetlist = new list(sizeof(triface), NULL, 256); - newtetlist = new list(sizeof(triface), NULL, 256); - gluetetlist = new list(sizeof(triface), NULL, 256); - glueshlist = new list(sizeof(face), NULL, 256); - newshlist = new list(sizeof(face), NULL, 256); + oldtetlist = new list(sizeof(triface), nullptr, 256); + newtetlist = new list(sizeof(triface), nullptr, 256); + gluetetlist = new list(sizeof(triface), nullptr, 256); + glueshlist = new list(sizeof(face), nullptr, 256); + newshlist = new list(sizeof(face), nullptr, 256); // Allocate work lists if user doesn't supply them. - myfrontlist = mymisfrontlist = myptlist = (list *) NULL; - myflipque = (queue *) NULL; - if (frontlist == (list *) NULL) { - myfrontlist = new list(sizeof(triface), NULL, 256); + myfrontlist = mymisfrontlist = myptlist = (list *) nullptr; + myflipque = (queue *) nullptr; + if (frontlist == (list *) nullptr) { + myfrontlist = new list(sizeof(triface), nullptr, 256); frontlist = myfrontlist; - mymisfrontlist = new list(sizeof(triface), NULL, 256); + mymisfrontlist = new list(sizeof(triface), nullptr, 256); misfrontlist = mymisfrontlist; - myptlist = new list(sizeof(point *), NULL, 256); + myptlist = new list(sizeof(point *), nullptr, 256); ptlist = myptlist; myflipque = new queue(sizeof(badface)); flipque = myflipque; @@ -25985,7 +25985,7 @@ bool tetgenmesh::suppressvolpoint(triface* suptet, list* frontlist, // Unable to suppress p. deallocfaketets(frontlist); // Try to collapse an edge at p. - conpt = (point) NULL; + conpt = (point) nullptr; assert(newtetlist->len() == 0); if (findcollapseedge(suppt, &conpt, oldtetlist, ptlist)) { // Collapse the edge suppt->conpt. Re-use newtetlist. @@ -26044,7 +26044,7 @@ bool tetgenmesh::suppressvolpoint(triface* suptet, list* frontlist, glueshlist->clear(); flipque->clear(); // Deallocate work lists. - if (myfrontlist != (list *) NULL) { + if (myfrontlist != (list *) nullptr) { delete myfrontlist; delete mymisfrontlist; delete myptlist; @@ -26087,12 +26087,12 @@ void tetgenmesh::removesteiners2() } // Initialize work lists. - frontlist = new list(sizeof(triface), NULL); - misfrontlist = new list(sizeof(triface), NULL); - spinshlist = new list(sizeof(face), NULL); - newsegshlist = new list(sizeof(face), NULL); - ptlist = new list(sizeof(point *), NULL); - conlist = new list(sizeof(point *) * 2, NULL); + frontlist = new list(sizeof(triface), nullptr); + misfrontlist = new list(sizeof(triface), nullptr); + spinshlist = new list(sizeof(face), nullptr); + newsegshlist = new list(sizeof(face), nullptr); + ptlist = new list(sizeof(point *), nullptr); + conlist = new list(sizeof(point *) * 2, nullptr); flipque = new queue(sizeof(badface)); viri = new memorypool(sizeof(shellface *), 1024, POINTER, 0); @@ -26115,7 +26115,7 @@ void tetgenmesh::removesteiners2() rmstein = unuverts; points->traversalinit(); pa = pointtraverse(); - while (pa != NULL) { + while (pa != nullptr) { j = pointmark(pa) - in->firstnumber; if (j >= in->numberofpoints) { // pa is not an input points. @@ -26189,8 +26189,8 @@ void tetgenmesh::removesteiners2() delete fixededgelist; delete elemfliplist; - fixededgelist = NULL; - elemfliplist = NULL; + fixededgelist = nullptr; + elemfliplist = nullptr; if (b->optlevel > 0) { // b->optlevel is set by -s. // Improve the local mesh quality at relocated Steiner points. @@ -26201,7 +26201,7 @@ void tetgenmesh::removesteiners2() // Smooth the relocated vertices (also count unsupressed vertices). points->traversalinit(); pa = pointtraverse(); - while (pa != NULL) { + while (pa != nullptr) { j = pointmark(pa) - in->firstnumber; if (j >= in->numberofpoints) { // pa is not an input point. @@ -26209,8 +26209,8 @@ void tetgenmesh::removesteiners2() if (vtype == FREEVOLVERTEX) { point2tetorg(pa, searchtet); frontlist->append(&searchtet); - formstarpolyhedron(pa, frontlist, NULL, false); - smoothpoint(pa, NULL, NULL, frontlist, false, NULL); + formstarpolyhedron(pa, frontlist, nullptr, false); + smoothpoint(pa, nullptr, nullptr, frontlist, false, nullptr); frontlist->clear(); } else if (vtype == FREESEGVERTEX) { remflag = false; @@ -26293,8 +26293,8 @@ void tetgenmesh::removesteiners2() delete caveshlist; delete caveshbdlist; - caveshlist = NULL; - caveshbdlist = NULL; + caveshlist = nullptr; + caveshbdlist = nullptr; // Delete work lists. delete frontlist; @@ -26482,7 +26482,7 @@ long tetgenmesh::reconstructmesh() // If -a switch is used (with no number follows) Set a volume // constraint if it exists. if (b->varvolume) { - if (in->tetrahedronvolumelist != (REAL *) NULL) { + if (in->tetrahedronvolumelist != (REAL *) nullptr) { volume = in->tetrahedronvolumelist[i]; } else { volume = -1.0; @@ -26503,7 +26503,7 @@ long tetgenmesh::reconstructmesh() // Loop all tetrahedra, bond two tetrahedra if they share a common face. tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Loop the four sides of the tetrahedron. for (tetloop.loc = 0; tetloop.loc < 4; tetloop.loc++) { sym(tetloop, neightet); @@ -26571,7 +26571,7 @@ long tetgenmesh::reconstructmesh() hullsize++; // It's a hull face. // Bond this side to outer space. dummytet[0] = encode(tetloop); - if ((in->pointmarkerlist != (int *) NULL) && !b->coarse) { + if ((in->pointmarkerlist != (int *) nullptr) && !b->coarse) { // Set its three corners's markers be boundary (hull) vertices. if (in->pointmarkerlist[iorg] == 0) { in->pointmarkerlist[iorg] = 1; @@ -26601,7 +26601,7 @@ long tetgenmesh::reconstructmesh() // interior faces which separate two different materials. // Phase (1). Is there a list of user-provided subfaces? - if (in->trifacelist != (int *) NULL) { + if (in->trifacelist != (int *) nullptr) { // Recover subfaces from 'in->trifacelist'. for (i = 0; i < in->numberoftrifaces; i++) { index = i * 3; @@ -26665,7 +26665,7 @@ long tetgenmesh::reconstructmesh() setpointtype(torg, FREESUBVERTEX); setpointtype(tdest, FREESUBVERTEX); setpointtype(tapex, FREESUBVERTEX); - if (in->trifacemarkerlist != (int *) NULL) { + if (in->trifacemarkerlist != (int *) nullptr) { setshellmark(subloop, in->trifacemarkerlist[i]); } adjustedgering(neightet, CCW); @@ -26690,7 +26690,7 @@ long tetgenmesh::reconstructmesh() // Phase (2). Indentify subfaces from the mesh. tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Loop the four sides of the tetrahedron. for (tetloop.loc = 0; tetloop.loc < 4; tetloop.loc++) { tspivot(tetloop, subloop); @@ -26739,14 +26739,14 @@ long tetgenmesh::reconstructmesh() // Set the connection between subfaces. A subsegment may have more than // two subfaces sharing it, 'neighshlist' stores all subfaces sharing // one edge. - neighshlist = new list(sizeof(face), NULL); + neighshlist = new list(sizeof(face), nullptr); // Create a map from nodes to subfaces. makesubfacemap(idx2facelist, facesperverlist); // Loop over the set of subfaces, setup the connection between subfaces. subfaces->traversalinit(); subloop.sh = shellfacetraverse(subfaces); - while (subloop.sh != (shellface *) NULL) { + while (subloop.sh != (shellface *) nullptr) { for (i = 0; i < 3; i++) { spivot(subloop, neighsh); if (neighsh.sh == dummysh) { @@ -26808,7 +26808,7 @@ long tetgenmesh::reconstructmesh() marker = 1; subfaces->traversalinit(); subloop.sh = shellfacetraverse(subfaces); - while (subloop.sh != (shellface *) NULL) { + while (subloop.sh != (shellface *) nullptr) { for (i = 0; i < 3; i++) { sspivot(subloop, subseg); if (subseg.sh == dummysh) { @@ -26871,11 +26871,11 @@ long tetgenmesh::reconstructmesh() // Find the acute vertices and set them be type ACUTEVERTEX. // Indentify facets and set the facet marker (1-based) for subfaces. - markerlist = new list(sizeof(int), NULL, 256); + markerlist = new list(sizeof(int), nullptr, 256); subfaces->traversalinit(); subloop.sh = shellfacetraverse(subfaces); - while (subloop.sh != (shellface *) NULL) { + while (subloop.sh != (shellface *) nullptr) { // Only operate on uninfected subface, after operating, infect it. if (!sinfected(subloop)) { // A new facet is found. @@ -26912,7 +26912,7 @@ long tetgenmesh::reconstructmesh() // Uninfect all subfaces. subfaces->traversalinit(); subloop.sh = shellfacetraverse(subfaces); - while (subloop.sh != (shellface *) NULL) { + while (subloop.sh != (shellface *) nullptr) { #ifdef SELF_CHECK assert(sinfected(subloop)); #endif @@ -26929,7 +26929,7 @@ long tetgenmesh::reconstructmesh() // Initialize the 'facetabovepointlist'. facetabovepointarray = new point[in->numberoffacets + 1]; for (i = 0; i < in->numberoffacets + 1; i++) { - facetabovepointarray[i] = (point) NULL; + facetabovepointarray[i] = (point) nullptr; } // The mesh contains boundary now. @@ -27046,7 +27046,7 @@ void tetgenmesh::insertconstrainedpoints(tetgenio *addio) // Perform a brute-force search. tetrahedrons->traversalinit(); searchtet.tet = tetrahedrontraverse(); - while (searchtet.tet != (tetrahedron *) NULL) { + while (searchtet.tet != (tetrahedron *) nullptr) { loc = adjustlocate(newpoint, &searchtet, OUTSIDE, b->epsilon2); if (loc != OUTSIDE) break; searchtet.tet = tetrahedrontraverse(); @@ -27163,7 +27163,7 @@ bool tetgenmesh::p1interpolatebgm(point pt, triface* bgmtet, long *scount) if (scount) (*scount)++; bgm->tetrahedrons->traversalinit(); // in bgm bgmtet->tet = bgm->tetrahedrontraverse(); // in bgm - while (bgmtet->tet != (tetrahedron *) NULL) { + while (bgmtet->tet != (tetrahedron *) nullptr) { loc = bgm->adjustlocate(pt, bgmtet, OUTSIDE, b->epsilon); if (loc != OUTSIDE) break; bgmtet->tet = bgm->tetrahedrontraverse(); // in bgm @@ -27190,7 +27190,7 @@ bool tetgenmesh::p1interpolatebgm(point pt, triface* bgmtet, long *scount) + weights[3] * bgmpt[3][bgm->pointmtrindex + i]; } } else { - setpoint2bgmtet(pt, (tetrahedron) NULL); // in m + setpoint2bgmtet(pt, (tetrahedron) nullptr); // in m } return loc != OUTSIDE; } @@ -27229,10 +27229,10 @@ void tetgenmesh::interpolatesizemap() tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { if (!infected(tetloop)) { // Find a new subdomain. - adjtetlist = new list(sizeof(triface), NULL, 1024); + adjtetlist = new list(sizeof(triface), nullptr, 1024); infect(tetloop); // Search the four corners in background mesh. for (i = 0; i < 4; i++) { @@ -27284,7 +27284,7 @@ void tetgenmesh::interpolatesizemap() // Unmark all tets. tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { assert(infected(tetloop)); uninfect(tetloop); tetloop.tet = tetrahedrontraverse(); @@ -27333,7 +27333,7 @@ void tetgenmesh::duplicatebgmesh() idx = in->firstnumber; points->traversalinit(); ploop = pointtraverse(); - while (ploop != (point) NULL) { + while (ploop != (point) nullptr) { bgm->makepoint(&bploop); // Copy coordinates, attributes. for (i = 0; i < 3 + in->numberofpointattributes; i++) { @@ -27359,7 +27359,7 @@ void tetgenmesh::duplicatebgmesh() idx = in->firstnumber; tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { bgm->maketetrahedron(&btetloop); // Set the four corners. for (i = 0; i < 4; i++) { @@ -27378,7 +27378,7 @@ void tetgenmesh::duplicatebgmesh() idx = in->firstnumber; tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Get the corresponding background tet. btetloop.tet = (tetrahedron *) tetloop.tet[4]; // Set the four neighbors. @@ -27417,7 +27417,7 @@ void tetgenmesh::duplicatebgmesh() // Connect bgm hull subfaces. Note: all hull subfaces form a 2-manifold. bgm->subfaces->traversalinit(); bhullsh.sh = bgm->shellfacetraverse(bgm->subfaces); - while (bhullsh.sh != (shellface *) NULL) { + while (bhullsh.sh != (shellface *) nullptr) { bhullsh.shver = 0; bgm->stpivot(bhullsh, btetloop); assert(btetloop.tet != bgm->dummytet); @@ -27485,13 +27485,13 @@ void tetgenmesh::marksharpsegments(REAL sharpangle) smallang = sharpangle * PI / 180.; sharpsegcount = 0; - eorg = edest = (point) NULL; // To avoid compiler warnings. + eorg = edest = (point) nullptr; // To avoid compiler warnings. // A segment s may have been split into many subsegments. Operate the one // which contains the origin of s. Then mark the rest of subsegments. subsegs->traversalinit(); segloop.sh = shellfacetraverse(subsegs); - while (segloop.sh != (shellface *) NULL) { + while (segloop.sh != (shellface *) nullptr) { segloop.shver = 0; senext2(segloop, prevseg); spivotself(prevseg); @@ -27542,7 +27542,7 @@ void tetgenmesh::marksharpsegments(REAL sharpangle) // angle between the two segments. ang = 0.0; do { - ang += interiorangle(eorg, sdest(neighsh), sapex(neighsh), NULL); + ang += interiorangle(eorg, sdest(neighsh), sapex(neighsh), nullptr); senext2self(neighsh); sspivot(neighsh, nextseg); if (nextseg.sh != dummysh) break; @@ -27593,7 +27593,7 @@ void tetgenmesh::marksharpsegments(REAL sharpangle) // there are possible ones whose DESTINATIONs have an acute angle. subsegs->traversalinit(); segloop.sh = shellfacetraverse(subsegs); - while (segloop.sh != (shellface *) NULL) { + while (segloop.sh != (shellface *) nullptr) { // Only operate if s is non-sharp and contains the dest. segloop.shver = 0; senext(segloop, nextseg); @@ -27615,7 +27615,7 @@ void tetgenmesh::marksharpsegments(REAL sharpangle) neighsh = spinsh; ang = 0.0; do { - ang += interiorangle(eorg, sdest(neighsh), sapex(neighsh), NULL); + ang += interiorangle(eorg, sdest(neighsh), sapex(neighsh), nullptr); senext2self(neighsh); sspivot(neighsh, nextseg); if (nextseg.sh != dummysh) break; @@ -27706,8 +27706,8 @@ void tetgenmesh::decidefeaturepointsizes() // Constructing a map from vertices to segments. makesegmentmap(idx2seglist, segsperverlist); // Initialize working lists. - tetlist = new list(sizeof(triface), NULL, 256); - verlist = new list(sizeof(point *), NULL, 256); + tetlist = new list(sizeof(triface), nullptr, 256); + verlist = new list(sizeof(point *), nullptr, 256); if (b->fixedvolume) { // A fixed volume constraint is imposed. This gives an upper bound of @@ -27721,7 +27721,7 @@ void tetgenmesh::decidefeaturepointsizes() featurecount = 0; points->traversalinit(); ploop = pointtraverse(); - while (ploop != (point) NULL) { + while (ploop != (point) nullptr) { if (pointtype(ploop) != FREESEGVERTEX) { // Is p a feature point? isfeature = false; @@ -27840,7 +27840,7 @@ void tetgenmesh::decidefeaturepointsizes() featurecount = 0; points->traversalinit(); ploop = pointtraverse(); - while (ploop != (point) NULL) { + while (ploop != (point) nullptr) { if (pointtype(ploop) == FREESEGVERTEX) { if (ploop[pointmtrindex] == 0.0) { sdecode(point2seg(ploop), checkseg); @@ -27909,7 +27909,7 @@ void tetgenmesh::decidefeaturepointsizes() // Have facet area constrains. subfaces->traversalinit(); shloop.sh = shellfacetraverse(subfaces); - while (shloop.sh != (shellface *) NULL) { + while (shloop.sh != (shellface *) nullptr) { varlen = areabound(shloop); if (varlen > 0.0) { // Check if the three corners are feature points. @@ -27938,7 +27938,7 @@ void tetgenmesh::decidefeaturepointsizes() // Have facet area constrains. subsegs->traversalinit(); shloop.sh = shellfacetraverse(subsegs); - while (shloop.sh != (shellface *) NULL) { + while (shloop.sh != (shellface *) nullptr) { varlen = areabound(shloop); if (varlen > 0.0) { // Check if the two endpoints are feature points. @@ -27991,7 +27991,7 @@ void tetgenmesh::enqueueencsub(face* testsub, point encpt, int quenumber, encsub->fapex = sapex(*testsub); encsub->foppo = (point) encpt; for (i = 0; i < 3; i++) encsub->cent[i] = cent[i]; - encsub->nextitem = (badface *) NULL; + encsub->nextitem = (badface *) nullptr; // Set the pointer of 'encsubseg' into 'testsub'. It has two purposes: // (1) We can regonize it is encroached; (2) It is uniquely queued. setshell2badface(encsub->ss, encsub); @@ -28028,18 +28028,18 @@ tetgenmesh::badface* tetgenmesh::dequeueencsub(int* pquenumber) // Look for a nonempty queue. for (quenumber = 2; quenumber >= 0; quenumber--) { result = subquefront[quenumber]; - if (result != (badface *) NULL) { + if (result != (badface *) nullptr) { // Remove the badface from the queue. subquefront[quenumber] = result->nextitem; // Maintain a pointer to the NULL pointer at the end of the queue. - if (subquefront[quenumber] == (badface *) NULL) { + if (subquefront[quenumber] == (badface *) nullptr) { subquetail[quenumber] = &subquefront[quenumber]; } *pquenumber = quenumber; return result; } } - return (badface *) NULL; + return (badface *) nullptr; } /////////////////////////////////////////////////////////////////////////////// @@ -28058,7 +28058,7 @@ void tetgenmesh::enqueuebadtet(triface* testtet, REAL ratio2, REAL* cent) newbadtet = (badface *) badtetrahedrons->alloc(); newbadtet->tt = *testtet; newbadtet->key = ratio2; - if (cent != NULL) { + if (cent != nullptr) { for (i = 0; i < 3; i++) newbadtet->cent[i] = cent[i]; } else { for (i = 0; i < 3; i++) newbadtet->cent[i] = 0.0; @@ -28067,7 +28067,7 @@ void tetgenmesh::enqueuebadtet(triface* testtet, REAL ratio2, REAL* cent) newbadtet->fdest = dest(*testtet); newbadtet->fapex = apex(*testtet); newbadtet->foppo = oppo(*testtet); - newbadtet->nextitem = (badface *) NULL; + newbadtet->nextitem = (badface *) nullptr; // Determine the appropriate queue to put the bad tetrahedron into. if (ratio2 > b->goodratio) { // queuenumber = (int) ((ratio2 - b->goodratio) / 0.5); @@ -28082,7 +28082,7 @@ void tetgenmesh::enqueuebadtet(triface* testtet, REAL ratio2, REAL* cent) } // Are we inserting into an empty queue? - if (tetquefront[queuenumber] == (badface *) NULL) { + if (tetquefront[queuenumber] == (badface *) nullptr) { // Yes. Will this become the highest-priority queue? if (queuenumber > firstnonemptyq) { // Yes, this is the highest-priority queue. @@ -28091,7 +28091,7 @@ void tetgenmesh::enqueuebadtet(triface* testtet, REAL ratio2, REAL* cent) } else { // No. Find the queue with next higher priority. i = queuenumber + 1; - while (tetquefront[i] == (badface *) NULL) { + while (tetquefront[i] == (badface *) nullptr) { i++; } // Mark the newly nonempty queue as following a higher-priority queue. @@ -28128,7 +28128,7 @@ tetgenmesh::badface* tetgenmesh::topbadtetra() recentq = firstnonemptyq; // If no queues are nonempty, return NULL. if (firstnonemptyq < 0) { - return (badface *) NULL; + return (badface *) nullptr; } else { // Return the first tetrahedron of the highest-priority queue. return tetquefront[firstnonemptyq]; @@ -28155,7 +28155,7 @@ void tetgenmesh::dequeuebadtet() } else { // No; find the queue with next higher priority. i = recentq + 1; - while (tetquefront[i] == (badface *) NULL) { + while (tetquefront[i] == (badface *) nullptr) { i++; } nextnonemptyq[i] = nextnonemptyq[recentq]; @@ -28207,7 +28207,7 @@ bool tetgenmesh::checkseg4encroach(face* testseg, point testpt, point* prefpt, if (!enq) { maxradius = 0.0; - if (testpt == (point) NULL) { + if (testpt == (point) nullptr) { // Check if it is encroached by traversing all faces containing it. sstpivot(testseg, &starttet); eapex = apex(starttet); @@ -28220,10 +28220,10 @@ bool tetgenmesh::checkseg4encroach(face* testseg, point testpt, point* prefpt, if (diff <= 0.0) { // s is encroached. enq = true; - if (prefpt != (point *) NULL) { + if (prefpt != (point *) nullptr) { // Find the reference point. encpt = apex(spintet); - circumsphere(eorg, edest, encpt, NULL, NULL, &dist); + circumsphere(eorg, edest, encpt, nullptr, nullptr, &dist); if (dist > maxradius) { // Rememebr this point. *prefpt = encpt; @@ -28264,7 +28264,7 @@ bool tetgenmesh::checkseg4encroach(face* testseg, point testpt, point* prefpt, encsubseg->ss = *testseg; encsubseg->forg = eorg; encsubseg->fdest = edest; - encsubseg->foppo = (point) NULL; // Not used. + encsubseg->foppo = (point) nullptr; // Not used. // Set the pointer of 'encsubseg' into 'testseg'. It has two purposes: // (1) We can regonize it is encroached; (2) It is uniquely queued. setshell2badface(encsubseg->ss, encsubseg); @@ -28307,7 +28307,7 @@ bool tetgenmesh::checksub4encroach(face* testsub, point testpt, bool enqflag) enq = false; radius = 0.0; - encpt = (point) NULL; + encpt = (point) nullptr; pa = sorg(*testsub); pb = sdest(*testsub); @@ -28347,7 +28347,7 @@ bool tetgenmesh::checksub4encroach(face* testsub, point testpt, bool enqflag) if (!enq) { // Check if the subface is encroached. - if (testpt == (point) NULL) { + if (testpt == (point) nullptr) { stpivot(*testsub, abuttet); if (abuttet.tet != dummytet) { dist = distance(cent, oppo(abuttet)); @@ -28508,7 +28508,7 @@ bool tetgenmesh::checktet4badqual(triface* testtet, bool enqflag) case 5: // edge ca. pe1 = pc; pe2 = pa; break; default: - pe1 = pe2 = (point) NULL; // Avoid a compile warning. + pe1 = pe2 = (point) nullptr; // Avoid a compile warning. } // The shortest edge is e1->e2. for (i = 0; i < 3; i++) bicent[i] = 0.5 * (pe1[i] + pe2[i]); @@ -28536,7 +28536,7 @@ bool tetgenmesh::checktet4badqual(triface* testtet, bool enqflag) if (!enq) { // Check if the user-defined sizing function is satisfied. if (b->metric) { - if (in->tetunsuitable != NULL) { + if (in->tetunsuitable != nullptr) { // Execute the user-defined meshing sizing evaluation. pa = (point) testtet->tet[4]; pb = (point) testtet->tet[5]; @@ -28637,7 +28637,7 @@ bool tetgenmesh::acceptsegpt(point segpt, point refpt, face* splitseg) if (j == 0) return true; // case (3). // If 'refpt' != NULL, force p to be inserted. - if (refpt != (point) NULL) { + if (refpt != (point) nullptr) { cdtenforcesegpts++; return true; } @@ -28785,7 +28785,7 @@ void tetgenmesh::getsplitpoint(point e1, point e2, point refpt, point newpt) bool acutea, acuteb; int i; - if (refpt != (point) NULL) { + if (refpt != (point) nullptr) { // Use the CDT rules to split the segment. acutea = (pointtype(e1) == ACUTEVERTEX); acuteb = (pointtype(e2) == ACUTEVERTEX); @@ -28847,9 +28847,9 @@ void tetgenmesh::setnewpointsize(point newpt, point e1, point e2) triface bgmtet; // Get a tet in background mesh for locating p. decode(point2bgmtet(e1), bgmtet); - p1interpolatebgm(newpt, &bgmtet, NULL); + p1interpolatebgm(newpt, &bgmtet, nullptr); } else { - if (e2 != (point) NULL) { + if (e2 != (point) nullptr) { // Interpolate the size between the two endpoints. REAL split, l, d; l = distance(e1, e2); @@ -28883,7 +28883,7 @@ bool tetgenmesh::splitencseg(point newpt, face* splitseg, list* tetlist, int i; if (optflag) { - mytetlist = new list(sizeof(triface), NULL, 1024); + mytetlist = new list(sizeof(triface), nullptr, 1024); myflipque = new queue(sizeof(badface)); tetlist = mytetlist; flipque = myflipque; @@ -28908,7 +28908,7 @@ bool tetgenmesh::splitencseg(point newpt, face* splitseg, list* tetlist, // Check the two new subsegs to see if they're encroached (not by p). for (i = 0; i < 2; i++) { //if (!shell2badface(*splitseg)) { - checkseg4encroach(splitseg, NULL, NULL, true); + checkseg4encroach(splitseg, nullptr, nullptr, true); //} if (i == 1) break; // Two new segs have been checked. senextself(*splitseg); @@ -28928,7 +28928,7 @@ bool tetgenmesh::splitencseg(point newpt, face* splitseg, list* tetlist, for (i = 0; i < sublist->len(); i++) { checksh = * (face *)(* sublist)[i]; //if (!shell2badface(checksh)) { - checksub4encroach(&checksh, NULL, true); + checksub4encroach(&checksh, nullptr, true); //} } sublist->clear(); @@ -29001,7 +29001,7 @@ bool tetgenmesh::tallencsegs(point testpt, int n, list **ceillists) // Count the number of encroached segments. enccount = 0; - if (ceillists != (list **) NULL) { + if (ceillists != (list **) nullptr) { for (k = 0; k < n; k++) { ceillist = ceillists[k]; // Check the segments on B_i(p). @@ -29013,7 +29013,7 @@ bool tetgenmesh::tallencsegs(point testpt, int n, list **ceillists) if (checkseg.sh != dummysh) { // Found a segment. Test it if it isn't in enc-list. // if (!shell2badface(checkseg)) { - if (checkseg4encroach(&checkseg, testpt, NULL, true)) { + if (checkseg4encroach(&checkseg, testpt, nullptr, true)) { enccount++; } // } @@ -29026,10 +29026,10 @@ bool tetgenmesh::tallencsegs(point testpt, int n, list **ceillists) // Check the entire list of segments. subsegs->traversalinit(); checkseg.sh = shellfacetraverse(subsegs); - while (checkseg.sh != (shellface *) NULL) { + while (checkseg.sh != (shellface *) nullptr) { // Test it if it isn't in enc-list. // if (!shell2badface(checkseg)) { - if (checkseg4encroach(&checkseg, testpt, NULL, true)) { + if (checkseg4encroach(&checkseg, testpt, nullptr, true)) { enccount++; } // } @@ -29067,7 +29067,7 @@ bool tetgenmesh::tallencsubs(point testpt, int n, list** ceillists) enccount = 0; // Count the number encroached subfaces. - if (ceillists != (list **) NULL) { + if (ceillists != (list **) nullptr) { for (k = 0; k < n; k++) { ceillist = ceillists[k]; // Check the subfaces on B_i(p). @@ -29088,7 +29088,7 @@ bool tetgenmesh::tallencsubs(point testpt, int n, list** ceillists) // Check the entire list of subfaces. subfaces->traversalinit(); checksh.sh = shellfacetraverse(subfaces); - while (checksh.sh != (shellface *) NULL) { + while (checksh.sh != (shellface *) nullptr) { // Test it if it isn't in enc-list. // if (!shell2badface(checksh)) { if (checksub4encroach(&checksh, testpt, true)) { @@ -29115,7 +29115,7 @@ void tetgenmesh::tallbadtetrahedrons() tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { checktet4badqual(&tetloop, true); tetloop.tet = tetrahedrontraverse(); } @@ -29155,8 +29155,8 @@ void tetgenmesh::repairencsegs(bool chkencsub, bool chkbadtet) sublists = new list*[nmax]; subceillists = new list*[nmax]; } else { - tetlist = new list(sizeof(triface), NULL, 1024); - sublist = new list(sizeof(face), NULL, 256); + tetlist = new list(sizeof(triface), nullptr, 1024); + sublist = new list(sizeof(face), nullptr, 256); flipque = new queue(sizeof(badface)); } @@ -29165,21 +29165,21 @@ void tetgenmesh::repairencsegs(bool chkencsub, bool chkbadtet) while ((badsubsegs->items > 0) && (steinerleft != 0)) { badsubsegs->traversalinit(); encloop = badfacetraverse(badsubsegs); - while ((encloop != (badface *) NULL) && (steinerleft != 0)) { + while ((encloop != (badface *) nullptr) && (steinerleft != 0)) { // Get an encroached subsegment s. splitseg = encloop->ss; // Clear the in-queue flag in s. - setshell2badface(splitseg, NULL); + setshell2badface(splitseg, nullptr); if ((sorg(splitseg) == encloop->forg) && (sdest(splitseg) == encloop->fdest)) { if (b->verbose > 1) { printf(" Get an enc-seg (%d, %d)\n", pointmark(encloop->forg), pointmark(encloop->fdest)); } - refpt = (point) NULL; + refpt = (point) nullptr; if (b->conformdel) { // Look for a reference point. - checkseg4encroach(&splitseg, NULL, &refpt, false); + checkseg4encroach(&splitseg, nullptr, &refpt, false); } // Create the new point p (at the middle of s). makepoint(&newpt); @@ -29193,17 +29193,17 @@ void tetgenmesh::repairencsegs(bool chkencsub, bool chkbadtet) if (shelltype(splitseg) == SHARP) { e2 = sdest(splitseg); } else { - e2 = (point) NULL; // No need to do size interoplation. + e2 = (point) nullptr; // No need to do size interoplation. } if (!b->fliprepair) { // Form BC(p), B(p), CBC(p)s, and C(p)s. - formbowatcavity(newpt, &splitseg, NULL, &n, &nmax, sublists, + formbowatcavity(newpt, &splitseg, nullptr, &n, &nmax, sublists, subceillists, tetlists, ceillists); // Validate/update BC(p), B(p), CBC(p)s, and C(p)s. if (trimbowatcavity(newpt, &splitseg, n, sublists, subceillists, tetlists, ceillists, -1.0)) { bowatinsertsite(newpt, &splitseg, n, sublists, subceillists, - tetlists, ceillists, NULL, flipque, true, + tetlists, ceillists, nullptr, flipque, true, chkencsub, chkbadtet); setnewpointsize(newpt, e1, e2); if (steinerleft > 0) steinerleft--; @@ -29215,7 +29215,7 @@ void tetgenmesh::repairencsegs(bool chkencsub, bool chkbadtet) releasebowatcavity(&splitseg, n, sublists, subceillists, tetlists, ceillists); } else { - if (splitencseg(newpt, &splitseg, tetlist, sublist, NULL, flipque, + if (splitencseg(newpt, &splitseg, tetlist, sublist, nullptr, flipque, chkencsub, chkbadtet, false)) { setnewpointsize(newpt, e1, e2); if (steinerleft > 0) steinerleft--; @@ -29280,9 +29280,9 @@ void tetgenmesh::repairencsubs(bool chkbadtet) int quenumber, n, i; n = 0; - sublist = (list *) NULL; - subceillist = (list *) NULL; - verlist = new list(sizeof(point *), NULL, 256); + sublist = (list *) nullptr; + subceillist = (list *) nullptr; + verlist = new list(sizeof(point *), nullptr, 256); // Loop until the pool 'badsubfaces' is empty. Note that steinerleft == -1 // if an unlimited number of Steiner points is allowed. @@ -29291,7 +29291,7 @@ void tetgenmesh::repairencsubs(bool chkbadtet) encloop = dequeueencsub(&quenumber); splitsub = encloop->ss; // Clear the in-queue flag of f. - setshell2badface(splitsub, NULL); + setshell2badface(splitsub, nullptr); // f may not be the same one when it was determined to be encroached. if (!isdead(&splitsub) && (sorg(splitsub) == encloop->forg) @@ -29309,7 +29309,7 @@ void tetgenmesh::repairencsubs(bool chkbadtet) setpoint2sh(newpt, sencode(splitsub)); // Set the abovepoint of f for point location. abovepoint = facetabovepointarray[shellmark(splitsub)]; - if (abovepoint == (point) NULL) { + if (abovepoint == (point) nullptr) { // getfacetabovepoint(&splitsub); // Calculate an abovepoint in dummypoint. facenormal2(encloop->forg, encloop->fdest, encloop->fapex, normal, 1); @@ -29331,7 +29331,7 @@ void tetgenmesh::repairencsubs(bool chkbadtet) loc = locatesub(newpt, &splitsub, 1, b->epsilon * 1e+2); if ((loc != ONVERTEX) && (loc != OUTSIDE)) { // Form BC(p), B(p), CBC(p) and C(p). - formbowatcavity(newpt, NULL, &splitsub, &n, NULL, &sublist, + formbowatcavity(newpt, nullptr, &splitsub, &n, nullptr, &sublist, &subceillist, tetlists, ceillists); // Check for encroached subsegments (on B(p)). oldencsegnum = badsubsegs->items; @@ -29353,7 +29353,7 @@ void tetgenmesh::repairencsubs(bool chkbadtet) } if (!reject) { // Validate/update cavity. - reject = !trimbowatcavity(newpt, NULL, n, &sublist, &subceillist, + reject = !trimbowatcavity(newpt, nullptr, n, &sublist, &subceillist, tetlists, ceillists, -1.0); } if (!reject) { @@ -29366,9 +29366,9 @@ void tetgenmesh::repairencsubs(bool chkbadtet) if (!reject) { // Save a point for size interpolation. e1 = sorg(splitsub); - bowatinsertsite(newpt, NULL, n, &sublist, &subceillist, tetlists, - ceillists, NULL, NULL, true, true, chkbadtet); - setnewpointsize(newpt, e1, NULL); + bowatinsertsite(newpt, nullptr, n, &sublist, &subceillist, tetlists, + ceillists, nullptr, nullptr, true, true, chkbadtet); + setnewpointsize(newpt, e1, nullptr); if (steinerleft > 0) steinerleft--; } else { // p is rejected for the one of the following reasons: @@ -29380,7 +29380,7 @@ void tetgenmesh::repairencsubs(bool chkbadtet) pointdealloc(newpt); } // if (!reject) // Release the cavity and free the memory. - releasebowatcavity(NULL,n,&sublist,&subceillist,tetlists,ceillists); + releasebowatcavity(nullptr,n,&sublist,&subceillist,tetlists,ceillists); if (reject) { // Are there queued encroached subsegments. if (badsubsegs->items > 0) { @@ -29465,9 +29465,9 @@ void tetgenmesh::repairbadtets() long oldptnum; int i; - tetlist = new list(sizeof(triface), NULL, 1024); - ceillist = new list(sizeof(triface), NULL, 1024); - verlist = new list(sizeof(point *), NULL, 256); + tetlist = new list(sizeof(triface), nullptr, 1024); + ceillist = new list(sizeof(triface), nullptr, 1024); + verlist = new list(sizeof(point *), nullptr, 256); histtetarray = new arraypool(sizeof(triface), 8); @@ -29478,7 +29478,7 @@ void tetgenmesh::repairbadtets() badtet = topbadtetra(); // Make sure that the tet is still the same one when it was tested. // Subsequent transformations may have made it a different tet. - if ((badtet != (badface *) NULL) && !isdead(&badtet->tt) + if ((badtet != (badface *) nullptr) && !isdead(&badtet->tt) && org(badtet->tt) == badtet->forg && dest(badtet->tt) == badtet->fdest && apex(badtet->tt) == badtet->fapex @@ -29516,7 +29516,7 @@ void tetgenmesh::repairbadtets() reject = !acceptvolpt(newpt, ceillist, verlist); } if (!reject) { - reject = !trimbowatcavity(newpt, NULL, 1, NULL, NULL, &tetlist, + reject = !trimbowatcavity(newpt, nullptr, 1, nullptr, nullptr, &tetlist, &ceillist, -1.0); } if (!reject) { @@ -29531,9 +29531,9 @@ void tetgenmesh::repairbadtets() // Save a point for size interpolation. e1 = org(starttet); // Insert p. - bowatinsertsite(newpt, NULL, 1, NULL, NULL, &tetlist, &ceillist, - NULL, NULL, false, false, true); - setnewpointsize(newpt, e1, NULL); + bowatinsertsite(newpt, nullptr, 1, nullptr, nullptr, &tetlist, &ceillist, + nullptr, nullptr, false, false, true); + setnewpointsize(newpt, e1, nullptr); if (steinerleft > 0) steinerleft--; } else { // p is rejected for one of the following reasons: @@ -29640,7 +29640,7 @@ void tetgenmesh::enforcequality() // Initialize the pool of encroached subsegments. badsubsegs = new memorypool(sizeof(badface), SUBPERBLOCK, POINTER, 0); // Looking for encroached subsegments. - tallencsegs(NULL, 0, NULL); + tallencsegs(nullptr, 0, nullptr); if (b->verbose && badsubsegs->items > 0) { printf(" Splitting encroached subsegments.\n"); } @@ -29655,10 +29655,10 @@ void tetgenmesh::enforcequality() // Initialize the pool of encroached subfaces. badsubfaces = new memorypool(sizeof(badface), SUBPERBLOCK, POINTER, 0); // Initialize the priority queues of badfaces. - for (i = 0; i < 3; i++) subquefront[i] = (badface *) NULL; + for (i = 0; i < 3; i++) subquefront[i] = (badface *) nullptr; for (i = 0; i < 3; i++) subquetail[i] = &subquefront[i]; // Looking for encroached subfaces. - tallencsubs(NULL, 0, NULL); + tallencsubs(nullptr, 0, nullptr); if (b->verbose && badsubfaces->items > 0) { printf(" Splitting encroached subfaces.\n"); } @@ -29677,7 +29677,7 @@ void tetgenmesh::enforcequality() // Initialize the pool of bad tets badtetrahedrons = new memorypool(sizeof(badface), ELEPERBLOCK, POINTER, 0); // Initialize the priority queues of bad tets. - for (i = 0; i < 64; i++) tetquefront[i] = (badface *) NULL; + for (i = 0; i < 64; i++) tetquefront[i] = (badface *) nullptr; firstnonemptyq = -1; recentq = -1; // Looking for bad quality tets. @@ -29771,7 +29771,7 @@ bool tetgenmesh::checktet4ill(triface* testtet, bool enqflag) newbadtet->fdest = dest(*testtet); newbadtet->fapex = apex(*testtet); newbadtet->foppo = oppo(*testtet); - newbadtet->nextitem = (badface *) NULL; + newbadtet->nextitem = (badface *) nullptr; if (b->verbose > 2) { printf(" Queueing illtet: (%d, %d, %d, %d).\n", pointmark(newbadtet->forg), pointmark(newbadtet->fdest), @@ -29814,7 +29814,7 @@ bool tetgenmesh::checktet4opt(triface* testtet, bool enqflag) pc = (point) testtet->tet[6]; pd = (point) testtet->tet[7]; // Compute the 4 face normals: N[0] cbd, N[1] acd, N[2] bad, N[3] abc. - tetallnormal(pa, pb, pc, pd, N, NULL); + tetallnormal(pa, pb, pc, pd, N, nullptr); // Normalize the normals. for (i = 0; i < 4; i++) { len = sqrt(dot(N[i], N[i])); @@ -29871,7 +29871,7 @@ bool tetgenmesh::checktet4opt(triface* testtet, bool enqflag) newbadtet->fdest = dest(*testtet); newbadtet->fapex = apex(*testtet); newbadtet->foppo = oppo(*testtet); - newbadtet->nextitem = (badface *) NULL; + newbadtet->nextitem = (badface *) nullptr; if (b->verbose > 2) { printf(" Queueing tet: (%d, %d, %d, %d), dihed %g (degree).\n", pointmark(newbadtet->forg), pointmark(newbadtet->fdest), @@ -30064,10 +30064,10 @@ bool tetgenmesh::removeedge(badface* remedge, bool optflag) // 2 < n < 20. if (n == 3) { // There are three tets at ab. Try to do a flip32 at ab. - remflag = removeedgebyflip32(&key, abtetlist, newtetlist, NULL); + remflag = removeedgebyflip32(&key, abtetlist, newtetlist, nullptr); } else if ((n > 3) && (n <= b->maxflipedgelinksize)) { // Four tets case. Try to do edge transformation. - remflag = removeedgebytranNM(&key,n,abtetlist,newtetlist,NULL,NULL,NULL); + remflag = removeedgebytranNM(&key,n,abtetlist,newtetlist,nullptr,nullptr,nullptr); } else { if (b->verbose > 1) { printf(" !! Unhandled case: n = %d.\n", n); @@ -30094,7 +30094,7 @@ bool tetgenmesh::removeedge(badface* remedge, bool optflag) // Try to do a combination of flips. n1 = 0; remflag = removeedgebycombNM(&key, n, abtetlist, &n1, bftetlist, - newtetlist, NULL); + newtetlist, nullptr); if (remflag) { optcount[9]++; // Delete the old tets. @@ -30172,7 +30172,7 @@ bool tetgenmesh::smoothpoint(point smthpt, point e1, point e2, list *starlist, int iter, i, j; // Is p a segment vertex? - segflag = (e1 != (point) NULL); + segflag = (e1 != (point) nullptr); // Decide the number of moving directions. numdirs = segflag ? 2 : starlist->len(); randflag = numdirs > 10; @@ -30283,7 +30283,7 @@ bool tetgenmesh::smoothpoint(point smthpt, point e1, point e2, list *starlist, pa = org(starttet); pb = dest(starttet); pc = apex(starttet); - tetalldihedral(pa, pb, pc, startpt, NULL, &cosd, NULL); + tetalldihedral(pa, pb, pc, startpt, nullptr, &cosd, nullptr); if (cosd < *key) { // This quality will not be improved. Stop. iter = 0; break; @@ -30343,8 +30343,8 @@ bool tetgenmesh::smoothsliver(badface* remedge, list *starlist) if (!(idx < in->numberofpoints)) { // Smooth a Steiner volume point. starlist->append(&(remedge->tt.tet)); - formstarpolyhedron(smthpt, starlist, NULL, false); - smthed = smoothpoint(smthpt,NULL,NULL,starlist,false,&remedge->key); + formstarpolyhedron(smthpt, starlist, nullptr, false); + smthed = smoothpoint(smthpt,nullptr,nullptr,starlist,false,&remedge->key); // If it is smoothed. Queue new bad tets. if (smthed) { for (j = 0; j < starlist->len(); j++) { @@ -30433,20 +30433,20 @@ bool tetgenmesh::splitsliver(badface *remedge, list *tetlist, list *ceillist) pt[0] = sorg(checkseg); pt[1] = sdest(checkseg); makepoint(&newpt); - getsplitpoint(pt[0], pt[1], NULL, newpt); + getsplitpoint(pt[0], pt[1], nullptr, newpt); setpointtype(newpt, FREESEGVERTEX); setpoint2seg(newpt, sencode(checkseg)); // Insert p, this should always success. sstpivot(&checkseg, &starttet); - splittetedge(newpt, &starttet, NULL); + splittetedge(newpt, &starttet, nullptr); // Collect the new tets connecting at p. sstpivot(&checkseg, &starttet); ceillist->append(&starttet); - formstarpolyhedron(newpt, ceillist, NULL, true); - setnewpointsize(newpt, pt[0], NULL); + formstarpolyhedron(newpt, ceillist, nullptr, true); + setnewpointsize(newpt, pt[0], nullptr); if (steinerleft > 0) steinerleft--; // Smooth p. - smoothpoint(newpt, pt[0], pt[1], ceillist, false, NULL); + smoothpoint(newpt, pt[0], pt[1], ceillist, false, nullptr); // Queue new slivers. for (i = 0; i < ceillist->len(); i++) { starttet = * (triface *)(* ceillist)[i]; @@ -30478,13 +30478,13 @@ bool tetgenmesh::splitsliver(badface *remedge, list *tetlist, list *ceillist) infect(starttet); tetlist->append(&starttet); formbowatcavityquad(newpt, tetlist, ceillist); - if (trimbowatcavity(newpt, NULL, 1, NULL, NULL, &tetlist, &ceillist, -1.0)) { + if (trimbowatcavity(newpt, nullptr, 1, nullptr, nullptr, &tetlist, &ceillist, -1.0)) { // Smooth p. - if (smoothpoint( newpt, NULL, NULL, ceillist, false, &remedge->key)) { + if (smoothpoint( newpt, nullptr, nullptr, ceillist, false, &remedge->key)) { // Insert p. - bowatinsertsite(newpt, NULL, 1, NULL, NULL, &tetlist, &ceillist, NULL, - NULL, false, false, false); - setnewpointsize(newpt, pt[0], NULL); + bowatinsertsite(newpt, nullptr, 1, nullptr, nullptr, &tetlist, &ceillist, nullptr, + nullptr, false, false, false); + setnewpointsize(newpt, pt[0], nullptr); if (steinerleft > 0) steinerleft--; // Queue new slivers. for (i = 0; i < ceillist->len(); i++) { @@ -30522,7 +30522,7 @@ void tetgenmesh::tallslivers(bool optflag) tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { if (optflag) { checktet4opt(&tetloop, true); } else { @@ -30623,7 +30623,7 @@ void tetgenmesh::optimizemesh2(bool optflag) // Loop in the list of bad tets. badtetrahedrons->traversalinit(); remtet = badfacetraverse(badtetrahedrons); - while (remtet != (badface *) NULL) { + while (remtet != (badface *) nullptr) { if (!isdead(&remtet->tt) && (org(remtet->tt) == remtet->forg) && (dest(remtet->tt) == remtet->fdest) && (apex(remtet->tt) == remtet->fapex) && @@ -30659,14 +30659,14 @@ void tetgenmesh::optimizemesh2(bool optflag) if ((badtetrahedrons->items > 0l) && optflag && (b->optlevel > 2)) { // Get a list of slivers and try to split them. - splittetlist = new list(sizeof(badface), NULL, 256); - tetlist = new list(sizeof(triface), NULL, 256); - ceillist = new list(sizeof(triface), NULL, 256); + splittetlist = new list(sizeof(badface), nullptr, 256); + tetlist = new list(sizeof(triface), nullptr, 256); + ceillist = new list(sizeof(triface), nullptr, 256); // Form a list of slivers to be split and clean the pool. badtetrahedrons->traversalinit(); remtet = badfacetraverse(badtetrahedrons); - while (remtet != (badface *) NULL) { + while (remtet != (badface *) nullptr) { splittetlist->append(remtet); remtet = badfacetraverse(badtetrahedrons); } @@ -30686,7 +30686,7 @@ void tetgenmesh::optimizemesh2(bool optflag) remtet->fapex = apex(remtet->tt); remtet->foppo = oppo(remtet->tt); tetalldihedral(remtet->forg, remtet->fdest, remtet->fapex, - remtet->foppo, cosdd, NULL, NULL); + remtet->foppo, cosdd, nullptr, nullptr); // Is it a large angle? if (cosdd[0] < cosobjdihed) { slivercount++; @@ -30748,7 +30748,7 @@ void tetgenmesh::optimizemesh2(bool optflag) } delete badtetrahedrons; - badtetrahedrons = (memorypool *) NULL; + badtetrahedrons = (memorypool *) nullptr; } //// //// @@ -30786,7 +30786,7 @@ void tetgenmesh::jettisonnodes() pointloop = pointtraverse(); oldidx = newidx = 0; // in->firstnumber; remcount = 0; - while (pointloop != (point) NULL) { + while (pointloop != (point) nullptr) { jetflag = (pointtype(pointloop) == DUPLICATEDVERTEX) || (pointtype(pointloop) == UNUSEDVERTEX); if (jetflag) { @@ -30796,7 +30796,7 @@ void tetgenmesh::jettisonnodes() } else { // Re-index it. setpointmark(pointloop, newidx + in->firstnumber); - if (in->pointmarkerlist != (int *) NULL) { + if (in->pointmarkerlist != (int *) nullptr) { if (oldidx < in->numberofpoints) { // Re-index the point marker as well. in->pointmarkerlist[newidx] = in->pointmarkerlist[oldidx]; @@ -30823,7 +30823,7 @@ void tetgenmesh::jettisonnodes() // The following line ensures that dead items in the pool of nodes cannot // be allocated for the new created nodes. This ensures that the input // nodes will occur earlier in the output files, and have lower indices. - points->deaditemstack = (void *) NULL; + points->deaditemstack = (void *) nullptr; } /////////////////////////////////////////////////////////////////////////////// @@ -30852,7 +30852,7 @@ void tetgenmesh::highorder() // Initialize the 'highordertable'. highordertable = new point[tetrahedrons->items * 6]; - if (highordertable == (point *) NULL) { + if (highordertable == (point *) nullptr) { terminatetetgen(1); } @@ -30861,17 +30861,17 @@ void tetgenmesh::highorder() // This ensures that the primary nodes (at the corners of elements) will // occur earlier in the output files, and have lower indices, than the // extra nodes. - points->deaditemstack = (void *) NULL; + points->deaditemstack = (void *) nullptr; // Assign an entry for each tetrahedron to find its extra nodes. At the // mean while, initialize all extra nodes be NULL. i = 0; tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { tetloop.tet[highorderindex] = (tetrahedron) &highordertable[i]; for (j = 0; j < 6; j++) { - highordertable[i + j] = (point) NULL; + highordertable[i + j] = (point) nullptr; } i += 6; tetloop.tet = tetrahedrontraverse(); @@ -30884,12 +30884,12 @@ void tetgenmesh::highorder() // node lists of all other tetrahedra sharing this edge. tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Get the list of extra nodes. extralist = (point *) tetloop.tet[highorderindex]; worktet.tet = tetloop.tet; for (i = 0; i < 6; i++) { - if (extralist[i] == (point) NULL) { + if (extralist[i] == (point) nullptr) { // Operate on this edge. worktet.loc = edge2locver[i][0]; worktet.ver = edge2locver[i][1]; @@ -30919,7 +30919,7 @@ void tetgenmesh::highorder() j = locver2edge[spintet.loc][spintet.ver]; // Only set 'newpoint' into 'adjextralist' if it is a NULL. // Because two faces can belong to the same tetrahedron. - if (adjextralist[j] == (point) NULL) { + if (adjextralist[j] == (point) nullptr) { adjextralist[j] = newpoint; } if (apex(spintet) == tapex) { @@ -30962,7 +30962,7 @@ void tetgenmesh::numberedges() meshedges = 0l; tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Count the number of Voronoi faces. Look at the six edges of each // tetrahedron. Count the edge only if the tetrahedron's pointer is // smaller than those of all other tetrahedra that share the edge. @@ -31017,13 +31017,13 @@ void tetgenmesh::outnodes(tetgenio* out) int pointnumber, firstindex; int index, i; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(outnodefilename, b->outfilename); strcat(outnodefilename, ".node"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", outnodefilename); } else { printf("Writing nodes.\n"); @@ -31034,12 +31034,12 @@ void tetgenmesh::outnodes(tetgenio* out) bmark = !b->nobound && in->pointmarkerlist; // Avoid compile warnings. - outfile = (FILE *) NULL; + outfile = (FILE *) nullptr; marker = coordindex = 0; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(outnodefilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", outnodefilename); terminatetetgen(3); } @@ -31049,20 +31049,20 @@ void tetgenmesh::outnodes(tetgenio* out) } else { // Allocate space for 'pointlist'; out->pointlist = new REAL[points->items * 3]; - if (out->pointlist == (REAL *) NULL) { + if (out->pointlist == (REAL *) nullptr) { terminatetetgen(1); } // Allocate space for 'pointattributelist' if necessary; if (nextras > 0) { out->pointattributelist = new REAL[points->items * nextras]; - if (out->pointattributelist == (REAL *) NULL) { + if (out->pointattributelist == (REAL *) nullptr) { terminatetetgen(1); } } // Allocate space for 'pointmarkerlist' if necessary; if (bmark) { out->pointmarkerlist = new int[points->items]; - if (out->pointmarkerlist == (int *) NULL) { + if (out->pointmarkerlist == (int *) nullptr) { terminatetetgen(1); } } @@ -31076,15 +31076,15 @@ void tetgenmesh::outnodes(tetgenio* out) // Initialize the point2tet field of each point. points->traversalinit(); pointloop = pointtraverse(); - while (pointloop != (point) NULL) { - setpoint2tet(pointloop, (tetrahedron) NULL); + while (pointloop != (point) nullptr) { + setpoint2tet(pointloop, (tetrahedron) nullptr); pointloop = pointtraverse(); } // Make a map point-to-subface. Hence a boundary point will get the // facet marker from that facet where it lies on. subfaces->traversalinit(); subloop.sh = shellfacetraverse(subfaces); - while (subloop.sh != (shellface *) NULL) { + while (subloop.sh != (shellface *) nullptr) { subloop.shver = 0; // Check all three points of the subface. for (i = 0; i < 3; i++) { @@ -31138,7 +31138,7 @@ void tetgenmesh::outnodes(tetgenio* out) pointloop = pointtraverse(); pointnumber = firstindex; // in->firstnumber; index = 0; - while (pointloop != (point) NULL) { + while (pointloop != (point) nullptr) { if (bmark) { // Default the vertex has a zero marker. marker = 0; @@ -31150,10 +31150,10 @@ void tetgenmesh::outnodes(tetgenio* out) // Is it a boundary vertex has marker zero? if ((marker == 0) && (b->plc || b->refine)) { subptr = (shellface) point2tet(pointloop); - if (subptr != (shellface) NULL) { + if (subptr != (shellface) nullptr) { // Default a boundary vertex has marker 1. marker = 1; - if (in->facetmarkerlist != (int *) NULL) { + if (in->facetmarkerlist != (int *) nullptr) { // The vertex gets the marker from the facet it lies on. sdecode(subptr, subloop); shmark = shellmark(subloop); @@ -31162,7 +31162,7 @@ void tetgenmesh::outnodes(tetgenio* out) } } } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { // Point number, x, y and z coordinates. fprintf(outfile, "%4d %.17g %.17g %.17g", pointnumber, pointloop[0], pointloop[1], pointloop[2]); @@ -31195,7 +31195,7 @@ void tetgenmesh::outnodes(tetgenio* out) index++; } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -31218,13 +31218,13 @@ void tetgenmesh::outmetrics(tetgenio* out) int mtrindex; int i; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(outmtrfilename, b->outfilename); strcat(outmtrfilename, ".mtr"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", outmtrfilename); } else { printf("Writing metrics.\n"); @@ -31232,12 +31232,12 @@ void tetgenmesh::outmetrics(tetgenio* out) } // Avoid compile warnings. - outfile = (FILE *) NULL; + outfile = (FILE *) nullptr; mtrindex = 0; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(outmtrfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", outmtrfilename); terminatetetgen(3); } @@ -31248,7 +31248,7 @@ void tetgenmesh::outmetrics(tetgenio* out) // Allocate space for 'pointmtrlist' if necessary; // out->pointmtrlist = new REAL[points->items * (sizeoftensor + 3)]; out->pointmtrlist = new REAL[points->items]; - if (out->pointmtrlist == (REAL *) NULL) { + if (out->pointmtrlist == (REAL *) nullptr) { terminatetetgen(1); } out->numberofpointmtrs = 1; // (sizeoftensor + 3); @@ -31258,14 +31258,14 @@ void tetgenmesh::outmetrics(tetgenio* out) // Initialize the point2tet field of each point. points->traversalinit(); ptloop = pointtraverse(); - while (ptloop != (point) NULL) { - setpoint2tet(ptloop, (tetrahedron) NULL); + while (ptloop != (point) nullptr) { + setpoint2tet(ptloop, (tetrahedron) nullptr); ptloop = pointtraverse(); } // Create the point-to-tet map. tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { for (i = 0; i < 4; i++) { ptloop = (point) tetloop.tet[4 + i]; setpoint2tet(ptloop, encode(tetloop)); @@ -31273,12 +31273,12 @@ void tetgenmesh::outmetrics(tetgenio* out) tetloop.tet = tetrahedrontraverse(); } - tetlist = new list(sizeof(triface), NULL, 256); - ptlist = new list(sizeof(point *), NULL, 256); + tetlist = new list(sizeof(triface), nullptr, 256); + ptlist = new list(sizeof(point *), nullptr, 256); points->traversalinit(); ptloop = pointtraverse(); - while (ptloop != (point) NULL) { + while (ptloop != (point) nullptr) { decode(point2tet(ptloop), tetloop); if (!isdead(&tetloop)) { // Form the star of p. @@ -31296,7 +31296,7 @@ void tetgenmesh::outmetrics(tetgenio* out) } lave /= ptlist->len(); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { // for (i = 0; i < sizeoftensor; i++) { // fprintf(outfile, "%-16.8e ", ptloop[pointmtrindex + i]); // } @@ -31329,7 +31329,7 @@ void tetgenmesh::outmetrics(tetgenio* out) delete tetlist; delete ptlist; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -31359,13 +31359,13 @@ void tetgenmesh::outelements(tetgenio* out) int eextras; int hitbdry, i; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(outelefilename, b->outfilename); strcat(outelefilename, ".ele"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", outelefilename); } else { printf("Writing elements.\n"); @@ -31373,15 +31373,15 @@ void tetgenmesh::outelements(tetgenio* out) } // Avoid compile warnings. - outfile = (FILE *) NULL; - tlist = (int *) NULL; - talist = (double *) NULL; + outfile = (FILE *) nullptr; + tlist = (int *) nullptr; + talist = (double *) nullptr; pointindex = attribindex = 0; eextras = in->numberoftetrahedronattributes; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(outelefilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", outelefilename); terminatetetgen(3); } @@ -31392,13 +31392,13 @@ void tetgenmesh::outelements(tetgenio* out) // Allocate memory for output tetrahedra. out->tetrahedronlist = new int[tetrahedrons->items * (b->order == 1 ? 4 : 10)]; - if (out->tetrahedronlist == (int *) NULL) { + if (out->tetrahedronlist == (int *) nullptr) { terminatetetgen(1); } // Allocate memory for output tetrahedron attributes if necessary. if (eextras > 0) { out->tetrahedronattributelist = new REAL[tetrahedrons->items * eextras]; - if (out->tetrahedronattributelist == (REAL *) NULL) { + if (out->tetrahedronattributelist == (REAL *) nullptr) { terminatetetgen(1); } } @@ -31424,7 +31424,7 @@ void tetgenmesh::outelements(tetgenio* out) tetrahedrons->traversalinit(); tptr = tetrahedrontraverse(); elementnumber = firstindex; // in->firstnumber; - while (tptr != (tetrahedron *) NULL) { + while (tptr != (tetrahedron *) nullptr) { if (b->noelewritten == 2) { // Reverse the orientation, such that Orient3D() > 0. p1 = (point) tptr[5]; @@ -31435,7 +31435,7 @@ void tetgenmesh::outelements(tetgenio* out) } p3 = (point) tptr[6]; p4 = (point) tptr[7]; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { // Tetrahedron number, indices for four points. fprintf(outfile, "%5d %5d %5d %5d %5d", elementnumber, pointmark(p1) - shift, pointmark(p2) - shift, @@ -31511,7 +31511,7 @@ void tetgenmesh::outelements(tetgenio* out) setelemmarker(dummytet, -1); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -31542,13 +31542,13 @@ void tetgenmesh::outfaces(tetgenio* out) int firstindex, shift; int facenumber; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(facefilename, b->outfilename); strcat(facefilename, ".face"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", facefilename); } else { printf("Writing faces.\n"); @@ -31556,17 +31556,17 @@ void tetgenmesh::outfaces(tetgenio* out) } // Avoid compile warnings. - outfile = (FILE *) NULL; - elist = (int *) NULL; - emlist = (int *) NULL; + outfile = (FILE *) nullptr; + elist = (int *) nullptr; + emlist = (int *) nullptr; index = marker = 0; faces = (4l * tetrahedrons->items + hullsize) / 2l; bmark = !b->nobound && in->facetmarkerlist; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(facefilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", facefilename); terminatetetgen(3); } @@ -31574,20 +31574,20 @@ void tetgenmesh::outfaces(tetgenio* out) } else { // Allocate memory for 'trifacelist'. out->trifacelist = new int[faces * 3]; - if (out->trifacelist == (int *) NULL) { + if (out->trifacelist == (int *) nullptr) { terminatetetgen(1); } // Allocate memory for 'trifacemarkerlist' if necessary. if (bmark) { out->trifacemarkerlist = new int[faces]; - if (out->trifacemarkerlist == (int *) NULL) { + if (out->trifacemarkerlist == (int *) nullptr) { terminatetetgen(1); } } if (b->neighout > 1) { // '-nn' switch. out->adjtetlist = new int[faces * 2]; - if (out->adjtetlist == (int *) NULL) { + if (out->adjtetlist == (int *) nullptr) { terminatetetgen(1); } } @@ -31613,7 +31613,7 @@ void tetgenmesh::outfaces(tetgenio* out) // adjacent tetrahedron, operate on the face only if the current // tetrahedron has a smaller pointer than its neighbor. This way, each // face is considered only once. - while (tface.tet != (tetrahedron *) NULL) { + while (tface.tet != (tetrahedron *) nullptr) { for (tface.loc = 0; tface.loc < 4; tface.loc ++) { sym(tface, tsymface); if ((tsymface.tet == dummytet) || (tface.tet < tsymface.tet)) { @@ -31648,7 +31648,7 @@ void tetgenmesh::outfaces(tetgenio* out) neigh2 = -1; } } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { // Face number, indices of three vertices. fprintf(outfile, "%5d %4d %4d %4d", facenumber, pointmark(torg) - shift, pointmark(tdest) - shift, @@ -31680,7 +31680,7 @@ void tetgenmesh::outfaces(tetgenio* out) tface.tet = tetrahedrontraverse(); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -31709,13 +31709,13 @@ void tetgenmesh::outhullfaces(tetgenio* out) int firstindex, shift; int facenumber; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(facefilename, b->outfilename); strcat(facefilename, ".face"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", facefilename); } else { printf("Writing faces.\n"); @@ -31723,13 +31723,13 @@ void tetgenmesh::outhullfaces(tetgenio* out) } // Avoid compile warnings. - outfile = (FILE *) NULL; - elist = (int *) NULL; + outfile = (FILE *) nullptr; + elist = (int *) nullptr; index = 0; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(facefilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", facefilename); terminatetetgen(3); } @@ -31737,7 +31737,7 @@ void tetgenmesh::outhullfaces(tetgenio* out) } else { // Allocate memory for 'trifacelist'. out->trifacelist = new int[hullsize * 3]; - if (out->trifacelist == (int *) NULL) { + if (out->trifacelist == (int *) nullptr) { terminatetetgen(1); } out->numberoftrifaces = hullsize; @@ -31758,14 +31758,14 @@ void tetgenmesh::outhullfaces(tetgenio* out) // To loop over the set of hull faces, loop over all tetrahedra, and look // at the four faces of each one. If there isn't another tetrahedron // adjacent to this face, operate on the face. - while (tface.tet != (tetrahedron *) NULL) { + while (tface.tet != (tetrahedron *) nullptr) { for (tface.loc = 0; tface.loc < 4; tface.loc ++) { sym(tface, tsymface); if (tsymface.tet == dummytet) { torg = org(tface); tdest = dest(tface); tapex = apex(tface); - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { // Face number, indices of three vertices. fprintf(outfile, "%5d %4d %4d %4d", facenumber, pointmark(torg) - shift, pointmark(tdest) - shift, @@ -31783,7 +31783,7 @@ void tetgenmesh::outhullfaces(tetgenio* out) tface.tet = tetrahedrontraverse(); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -31815,13 +31815,13 @@ void tetgenmesh::outsubfaces(tetgenio* out) int neigh1, neigh2; int facenumber; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(facefilename, b->outfilename); strcat(facefilename, ".face"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", facefilename); } else { printf("Writing faces.\n"); @@ -31829,18 +31829,18 @@ void tetgenmesh::outsubfaces(tetgenio* out) } // Avoid compile warnings. - outfile = (FILE *) NULL; - elist = (int *) NULL; - emlist = (int *) NULL; + outfile = (FILE *) nullptr; + elist = (int *) nullptr; + emlist = (int *) nullptr; index = index1 = index2 = 0; faceid = marker = 0; neigh1 = neigh2 = 0; bmark = !b->nobound && in->facetmarkerlist; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(facefilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", facefilename); terminatetetgen(3); } @@ -31849,20 +31849,20 @@ void tetgenmesh::outsubfaces(tetgenio* out) } else { // Allocate memory for 'trifacelist'. out->trifacelist = new int[subfaces->items * 3]; - if (out->trifacelist == (int *) NULL) { + if (out->trifacelist == (int *) nullptr) { terminatetetgen(1); } if (bmark) { // Allocate memory for 'trifacemarkerlist'. out->trifacemarkerlist = new int[subfaces->items]; - if (out->trifacemarkerlist == (int *) NULL) { + if (out->trifacemarkerlist == (int *) nullptr) { terminatetetgen(1); } } if (b->neighout > 1) { // '-nn' switch. out->adjtetlist = new int[subfaces->items * 2]; - if (out->adjtetlist == (int *) NULL) { + if (out->adjtetlist == (int *) nullptr) { terminatetetgen(1); } } @@ -31881,7 +31881,7 @@ void tetgenmesh::outsubfaces(tetgenio* out) subfaces->traversalinit(); faceloop.sh = shellfacetraverse(subfaces); facenumber = firstindex; // in->firstnumber; - while (faceloop.sh != (shellface *) NULL) { + while (faceloop.sh != (shellface *) nullptr) { stpivot(faceloop, abuttingtet); if (abuttingtet.tet == dummytet) { sesymself(faceloop); @@ -31921,7 +31921,7 @@ void tetgenmesh::outsubfaces(tetgenio* out) neigh2 = getelemmarker(abuttingtet.tet); } } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "%5d %4d %4d %4d", facenumber, pointmark(torg) - shift, pointmark(tdest) - shift, pointmark(tapex) - shift); @@ -31949,7 +31949,7 @@ void tetgenmesh::outsubfaces(tetgenio* out) faceloop.sh = shellfacetraverse(subfaces); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -31974,13 +31974,13 @@ void tetgenmesh::outedges(tetgenio* out) int edgenumber, faceid, marker; int hitbdry, i; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(edgefilename, b->outfilename); strcat(edgefilename, ".edge"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", edgefilename); } else { printf("Writing edges.\n"); @@ -31988,15 +31988,15 @@ void tetgenmesh::outedges(tetgenio* out) } // Avoid compile warnings. - outfile = (FILE *) NULL; - elist = (int *) NULL; - emlist = (int *) NULL; + outfile = (FILE *) nullptr; + elist = (int *) nullptr; + emlist = (int *) nullptr; index = index1 = 0; faceid = marker = 0; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(edgefilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", edgefilename); terminatetetgen(3); } @@ -32005,7 +32005,7 @@ void tetgenmesh::outedges(tetgenio* out) } else { // Allocate memory for 'edgelist'. out->edgelist = new int[meshedges * 2]; - if (out->edgelist == (int *) NULL) { + if (out->edgelist == (int *) nullptr) { terminatetetgen(1); } if (!b->nobound) { @@ -32026,7 +32026,7 @@ void tetgenmesh::outedges(tetgenio* out) tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); edgenumber = firstindex; // in->firstnumber; - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Count the number of Voronoi faces. Look at the six edges of each // tetrahedron. Count the edge only if the tetrahedron's pointer is // smaller than those of all other tetrahedra that share the edge. @@ -32053,7 +32053,7 @@ void tetgenmesh::outedges(tetgenio* out) if (spintet.tet >= worktet.tet) { torg = org(worktet); tdest = dest(worktet); - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "%5d %4d %4d", edgenumber, pointmark(torg) - shift, pointmark(tdest) - shift); } else { @@ -32072,13 +32072,13 @@ void tetgenmesh::outedges(tetgenio* out) } else { marker = 0; // It's not a segment. } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, " %d", marker); } else { emlist[index1++] = marker; } } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "\n"); } edgenumber++; @@ -32087,7 +32087,7 @@ void tetgenmesh::outedges(tetgenio* out) tetloop.tet = tetrahedrontraverse(); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -32110,13 +32110,13 @@ void tetgenmesh::outsubsegments(tetgenio* out) int firstindex, shift; int edgenumber; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(edgefilename, b->outfilename); strcat(edgefilename, ".edge"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", edgefilename); } else { printf("Writing edges.\n"); @@ -32124,13 +32124,13 @@ void tetgenmesh::outsubsegments(tetgenio* out) } // Avoid compile warnings. - outfile = (FILE *) NULL; - elist = (int *) NULL; + outfile = (FILE *) nullptr; + elist = (int *) nullptr; index = 0; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(edgefilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", edgefilename); terminatetetgen(3); } @@ -32139,7 +32139,7 @@ void tetgenmesh::outsubsegments(tetgenio* out) } else { // Allocate memory for 'edgelist'. out->edgelist = new int[subsegs->items * 2]; - if (out->edgelist == (int *) NULL) { + if (out->edgelist == (int *) nullptr) { terminatetetgen(1); } out->numberofedges = subsegs->items; @@ -32156,10 +32156,10 @@ void tetgenmesh::outsubsegments(tetgenio* out) subsegs->traversalinit(); edgeloop.sh = shellfacetraverse(subsegs); edgenumber = firstindex; // in->firstnumber; - while (edgeloop.sh != (shellface *) NULL) { + while (edgeloop.sh != (shellface *) nullptr) { torg = sorg(edgeloop); tdest = sdest(edgeloop); - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "%5d %4d %4d\n", edgenumber, pointmark(torg) - shift, pointmark(tdest) - shift); } else { @@ -32171,7 +32171,7 @@ void tetgenmesh::outsubsegments(tetgenio* out) edgeloop.sh = shellfacetraverse(subsegs); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -32194,13 +32194,13 @@ void tetgenmesh::outneighbors(tetgenio* out) int firstindex; int elementnumber; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(neighborfilename, b->outfilename); strcat(neighborfilename, ".neigh"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", neighborfilename); } else { printf("Writing neighbors.\n"); @@ -32208,13 +32208,13 @@ void tetgenmesh::outneighbors(tetgenio* out) } // Avoid compile warnings. - outfile = (FILE *) NULL; - nlist = (int *) NULL; + outfile = (FILE *) nullptr; + nlist = (int *) nullptr; index = 0; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(neighborfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", neighborfilename); terminatetetgen(3); } @@ -32223,7 +32223,7 @@ void tetgenmesh::outneighbors(tetgenio* out) } else { // Allocate memory for 'neighborlist'. out->neighborlist = new int[tetrahedrons->items * 4]; - if (out->neighborlist == (int *) NULL) { + if (out->neighborlist == (int *) nullptr) { terminatetetgen(1); } nlist = out->neighborlist; @@ -32235,7 +32235,7 @@ void tetgenmesh::outneighbors(tetgenio* out) tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); elementnumber = firstindex; // in->firstnumber; - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { tetloop.loc = 2; sym(tetloop, tetsym); //neighbor1 = * (int *) (tetsym.tet + elemmarkerindex); @@ -32252,7 +32252,7 @@ void tetgenmesh::outneighbors(tetgenio* out) sym(tetloop, tetsym); //neighbor4 = * (int *) (tetsym.tet + elemmarkerindex); neighbor4 = getelemmarker(tetsym.tet); - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { // Tetrahedra number, neighboring tetrahedron numbers. fprintf(outfile, "%4d %4d %4d %4d %4d\n", elementnumber, neighbor1, neighbor2, neighbor3, neighbor4); @@ -32266,7 +32266,7 @@ void tetgenmesh::outneighbors(tetgenio* out) elementnumber++; } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -32311,13 +32311,13 @@ void tetgenmesh::outvoronoi(tetgenio* out) int hitbdry, i, j, k; // Output Voronoi vertices to .v.node file. - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(outfilename, b->outfilename); strcat(outfilename, ".v.node"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", outfilename); } else { printf("Writing Voronoi vertices.\n"); @@ -32331,11 +32331,11 @@ void tetgenmesh::outvoronoi(tetgenio* out) // The number of Delaunay edges (= the number of Voronoi faces). // edges = points->items + faces - tetrahedrons->items - 1; edges = meshedges; - outfile = (FILE *) NULL; // Avoid compile warnings. + outfile = (FILE *) nullptr; // Avoid compile warnings. - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(outfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", outfilename); terminatetetgen(3); } @@ -32345,7 +32345,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) // Allocate space for 'vpointlist'. out->numberofvpoints = (int) tetrahedrons->items; out->vpointlist = new REAL[out->numberofvpoints * 3]; - if (out->vpointlist == (REAL *) NULL) { + if (out->vpointlist == (REAL *) nullptr) { terminatetetgen(1); } } @@ -32357,14 +32357,14 @@ void tetgenmesh::outvoronoi(tetgenio* out) tetloop.tet = tetrahedrontraverse(); vpointcount = 0; index = 0; - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Calculate the circumcenter. for (i = 0; i < 4; i++) { pt[i] = (point) tetloop.tet[4 + i]; setpoint2tet(pt[i], encode(tetloop)); } - circumsphere(pt[0], pt[1], pt[2], pt[3], ccent, NULL); - if (out == (tetgenio *) NULL) { + circumsphere(pt[0], pt[1], pt[2], pt[3], ccent, nullptr); + if (out == (tetgenio *) nullptr) { fprintf(outfile, "%4d %16.8e %16.8e %16.8e\n", vpointcount + shift, ccent[0], ccent[1], ccent[2]); } else { @@ -32380,28 +32380,28 @@ void tetgenmesh::outvoronoi(tetgenio* out) // Set the outside element marker. * (int *) (dummytet + elemmarkerindex) = -1; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } // Output Voronoi edges to .v.edge file. - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(outfilename, b->outfilename); strcat(outfilename, ".v.edge"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", outfilename); } else { printf("Writing Voronoi edges.\n"); } } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(outfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", outfilename); terminatetetgen(3); } @@ -32423,7 +32423,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) tetloop.tet = tetrahedrontraverse(); vedgecount = 0; index = 0; - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Count the number of Voronoi edges. Look at the four faces of each // tetrahedron. Count the face if the tetrahedron's pointer is // smaller than its neighbor's or the neighbor is outside. @@ -32431,7 +32431,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) for (i = 0; i < 4; i++) { decode(tetloop.tet[i], worktet); if ((worktet.tet == dummytet) || (tetloop.tet < worktet.tet)) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "%4d %4d", vedgecount + shift, end1 + shift); } else { vedge = &(out->vedgelist[index++]); @@ -32454,7 +32454,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) L = sqrt(infvec[0] * infvec[0] + infvec[1] * infvec[1] + infvec[2] * infvec[2]); if (L > 0) for (j = 0; j < 3; j++) infvec[j] /= L; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, " -1"); fprintf(outfile, " %g %g %g\n", infvec[0], infvec[1], infvec[2]); } else { @@ -32464,7 +32464,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) vedge->vnormal[2] = infvec[2]; } } else { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, " %4d\n", end2 + shift); } else { vedge->v2 = end2 + shift; @@ -32484,28 +32484,28 @@ void tetgenmesh::outvoronoi(tetgenio* out) tetloop.tet = tetrahedrontraverse(); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } // Output Voronoi faces to .v.face file. - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(outfilename, b->outfilename); strcat(outfilename, ".v.face"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", outfilename); } else { printf("Writing Voronoi faces.\n"); } } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(outfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", outfilename); terminatetetgen(3); } @@ -32514,7 +32514,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) } else { out->numberofvfacets = edges; out->vfacetlist = new tetgenio::vorofacet[out->numberofvfacets]; - if (out->vfacetlist == (tetgenio::vorofacet *) NULL) { + if (out->vfacetlist == (tetgenio::vorofacet *) nullptr) { terminatetetgen(1); } } @@ -32528,7 +32528,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); vfacecount = 0; - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Count the number of Voronoi faces. Look at the six edges of each // tetrahedron. Count the edge only if the tetrahedron's pointer is // smaller than those of all other tetrahedra that share the edge. @@ -32561,7 +32561,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) pt[1] = dest(worktet); end1 = pointmark(pt[0]) - in->firstnumber; end2 = pointmark(pt[1]) - in->firstnumber; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "%4d %4d %4d %-2d ", vfacecount + shift, end1 + shift, end2 + shift, tcount + (hitbdry > 0)); } else { @@ -32577,7 +32577,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) // The edge list starts with a ray. vpointcount = * (int *) (spintet.tet + elemmarkerindex); vedgecount = tetfaceindexarray[vpointcount * 4 + spintet.loc]; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, " %d", vedgecount + shift); } else { vfacet->elist[index++] = vedgecount + shift; @@ -32592,7 +32592,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) for (j = 0; j < tcount; j++) { vpointcount = * (int *) (spintet.tet + elemmarkerindex); vedgecount = tetfaceindexarray[vpointcount * 4 + spintet.loc]; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, " %d", vedgecount + shift); } else { vfacet->elist[index++] = vedgecount + shift; @@ -32602,7 +32602,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) locver2edge[spintet.loc][spintet.ver]] = vfacecount; fnextself(spintet); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "\n"); } vfacecount++; @@ -32611,28 +32611,28 @@ void tetgenmesh::outvoronoi(tetgenio* out) tetloop.tet = tetrahedrontraverse(); } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } // Output Voronoi cells to .v.cell file. - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { strcpy(outfilename, b->outfilename); strcat(outfilename, ".v.cell"); } if (!b->quiet) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { printf("Writing %s.\n", outfilename); } else { printf("Writing Voronoi cells.\n"); } } - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { outfile = fopen(outfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", outfilename); terminatetetgen(3); } @@ -32641,18 +32641,18 @@ void tetgenmesh::outvoronoi(tetgenio* out) } else { out->numberofvcells = points->items; out->vcelllist = new int*[out->numberofvcells]; - if (out->vcelllist == (int **) NULL) { + if (out->vcelllist == (int **) nullptr) { terminatetetgen(1); } } // Loop through point list, for each point, output a Voronoi cell. - tetlist = new list(sizeof(triface), NULL, 256); - ptlist = new list(sizeof(point *), NULL, 256); + tetlist = new list(sizeof(triface), nullptr, 256); + ptlist = new list(sizeof(point *), nullptr, 256); points->traversalinit(); ptloop = pointtraverse(); vpointcount = 0; - while (ptloop != (point) NULL) { + while (ptloop != (point) nullptr) { decode(point2tet(ptloop), tetloop); // assert(!isdead(&tetloop)); if (!isdead(&tetloop)) { @@ -32660,7 +32660,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) tetlist->append(&tetloop); formstarpolyhedron(ptloop, tetlist, ptlist, true); tcount = ptlist->len(); - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "%4d %-2d ", vpointcount + shift, tcount); } else { arraysize = tcount; @@ -32690,13 +32690,13 @@ void tetgenmesh::outvoronoi(tetgenio* out) // k is the right edge number. end1 = * (int *) (tetloop.tet + elemmarkerindex); vfacecount = tetedgeindexarray[end1 * 6 + k]; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, " %d", vfacecount + shift); } else { vertarray[index++] = vfacecount + shift; } } // for (i = 0; i < ptlist->len(); i++) { - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "\n"); } vpointcount++; @@ -32710,7 +32710,7 @@ void tetgenmesh::outvoronoi(tetgenio* out) delete [] tetfaceindexarray; delete [] tetedgeindexarray; - if (out == (tetgenio *) NULL) { + if (out == (tetgenio *) nullptr) { fprintf(outfile, "# Generated by %s\n", b->commandline); fclose(outfile); } @@ -32739,7 +32739,7 @@ void tetgenmesh::outsmesh(char* smfilename) int faceid, marker; int i; - if (smfilename != (char *) NULL && smfilename[0] != '\0') { + if (smfilename != (char *) nullptr && smfilename[0] != '\0') { strcpy(smefilename, smfilename); } else if (b->outfilename[0] != '\0') { strcpy(smefilename, b->outfilename); @@ -32754,7 +32754,7 @@ void tetgenmesh::outsmesh(char* smfilename) printf("Writing %s.\n", smefilename); } outfile = fopen(smefilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", smefilename); return; } @@ -32779,7 +32779,7 @@ void tetgenmesh::outsmesh(char* smfilename) subfaces->traversalinit(); faceloop.sh = shellfacetraverse(subfaces); - while (faceloop.sh != (shellface *) NULL) { + while (faceloop.sh != (shellface *) nullptr) { p1 = sorg(faceloop); p2 = sdest(faceloop); p3 = sapex(faceloop); @@ -32846,7 +32846,7 @@ void tetgenmesh::outmesh2medit(char* mfilename) int pointnumber; int i; - if (mfilename != (char *) NULL && mfilename[0] != '\0') { + if (mfilename != (char *) nullptr && mfilename[0] != '\0') { strcpy(mefilename, mfilename); } else if (b->outfilename[0] != '\0') { strcpy(mefilename, b->outfilename); @@ -32859,7 +32859,7 @@ void tetgenmesh::outmesh2medit(char* mfilename) printf("Writing %s.\n", mefilename); } outfile = fopen(mefilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", mefilename); return; } @@ -32877,7 +32877,7 @@ void tetgenmesh::outmesh2medit(char* mfilename) points->traversalinit(); ptloop = pointtraverse(); pointnumber = 1; // Medit need start number form 1. - while (ptloop != (point) NULL) { + while (ptloop != (point) nullptr) { // Point coordinates. fprintf(outfile, "%.17g %.17g %.17g", ptloop[0], ptloop[1], ptloop[2]); if (in->numberofpointattributes > 0) { @@ -32906,7 +32906,7 @@ void tetgenmesh::outmesh2medit(char* mfilename) // acent tetrahedron, operate on the face only if the current tetrahedron // has a smaller pointer than its neighbor. This way, each face is // considered only once. - while (tface.tet != (tetrahedron *) NULL) { + while (tface.tet != (tetrahedron *) nullptr) { for (tface.loc = 0; tface.loc < 4; tface.loc ++) { sym(tface, tsymface); if (tface.tet < tsymface.tet || tsymface.tet == dummytet) { @@ -32927,7 +32927,7 @@ void tetgenmesh::outmesh2medit(char* mfilename) tetrahedrons->traversalinit(); tetptr = tetrahedrontraverse(); - while (tetptr != (tetrahedron *) NULL) { + while (tetptr != (tetrahedron *) nullptr) { p1 = (point) tetptr[4]; p2 = (point) tetptr[5]; p3 = (point) tetptr[6]; @@ -32956,7 +32956,7 @@ void tetgenmesh::outmesh2medit(char* mfilename) subsegs->traversalinit(); segloop.sh = shellfacetraverse(subsegs); - while (segloop.sh != (shellface *) NULL) { + while (segloop.sh != (shellface *) nullptr) { p1 = sorg(segloop); p2 = sdest(segloop); fprintf(outfile, "%5d %5d", pointmark(p1), pointmark(p2)); @@ -32992,7 +32992,7 @@ void tetgenmesh::outmesh2gid(char* gfilename) int pointnumber; int elementnumber; - if (gfilename != (char *) NULL && gfilename[0] != '\0') { + if (gfilename != (char *) nullptr && gfilename[0] != '\0') { strcpy(gidfilename, gfilename); } else if (b->outfilename[0] != '\0') { strcpy(gidfilename, b->outfilename); @@ -33005,7 +33005,7 @@ void tetgenmesh::outmesh2gid(char* gfilename) printf("Writing %s.\n", gidfilename); } outfile = fopen(gidfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", gidfilename); return; } @@ -33016,7 +33016,7 @@ void tetgenmesh::outmesh2gid(char* gfilename) points->traversalinit(); ptloop = pointtraverse(); pointnumber = 1; // Gid need start number form 1. - while (ptloop != (point) NULL) { + while (ptloop != (point) nullptr) { // Point coordinates. fprintf(outfile, "%4d %.17g %.17g %.17g", pointnumber, ptloop[0], ptloop[1], ptloop[2]); @@ -33036,7 +33036,7 @@ void tetgenmesh::outmesh2gid(char* gfilename) tetrahedrons->traversalinit(); tetptr = tetrahedrontraverse(); elementnumber = 1; - while (tetptr != (tetrahedron *) NULL) { + while (tetptr != (tetrahedron *) nullptr) { p1 = (point) tetptr[4]; p2 = (point) tetptr[5]; p3 = (point) tetptr[6]; @@ -33054,7 +33054,7 @@ void tetgenmesh::outmesh2gid(char* gfilename) fprintf(outfile, "end elements\n"); fclose(outfile); - if (gfilename != (char *) NULL && gfilename[0] != '\0') { + if (gfilename != (char *) nullptr && gfilename[0] != '\0') { strcpy(gidfilename, gfilename); } else if (b->outfilename[0] != '\0') { strcpy(gidfilename, b->outfilename); @@ -33067,7 +33067,7 @@ void tetgenmesh::outmesh2gid(char* gfilename) printf("Writing %s.\n", gidfilename); } outfile = fopen(gidfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", gidfilename); return; } @@ -33078,7 +33078,7 @@ void tetgenmesh::outmesh2gid(char* gfilename) points->traversalinit(); ptloop = pointtraverse(); pointnumber = 1; // Gid need start number form 1. - while (ptloop != (point) NULL) { + while (ptloop != (point) nullptr) { // Point coordinates. fprintf(outfile, "%4d %.17g %.17g %.17g", pointnumber, ptloop[0], ptloop[1], ptloop[2]); @@ -33098,7 +33098,7 @@ void tetgenmesh::outmesh2gid(char* gfilename) tetrahedrons->traversalinit(); tface.tet = tetrahedrontraverse(); elementnumber = 1; - while (tface.tet != (tetrahedron *) NULL) { + while (tface.tet != (tetrahedron *) nullptr) { for (tface.loc = 0; tface.loc < 4; tface.loc ++) { sym(tface, tsymface); if ((tface.tet < tsymface.tet) || (tsymface.tet == dummytet)) { @@ -33146,7 +33146,7 @@ void tetgenmesh::outmesh2off(char* ofilename) long faces; int shift; - if (ofilename != (char *) NULL && ofilename[0] != '\0') { + if (ofilename != (char *) nullptr && ofilename[0] != '\0') { strcpy(offfilename, ofilename); } else if (b->outfilename[0] != '\0') { strcpy(offfilename, b->outfilename); @@ -33159,7 +33159,7 @@ void tetgenmesh::outmesh2off(char* ofilename) printf("Writing %s.\n", offfilename); } outfile = fopen(offfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", offfilename); return; } @@ -33173,7 +33173,7 @@ void tetgenmesh::outmesh2off(char* ofilename) // Write the points. points->traversalinit(); ptloop = pointtraverse(); - while (ptloop != (point) NULL) { + while (ptloop != (point) nullptr) { fprintf(outfile, " %.17g %.17g %.17g\n",ptloop[0], ptloop[1], ptloop[2]); ptloop = pointtraverse(); } @@ -33189,7 +33189,7 @@ void tetgenmesh::outmesh2off(char* ofilename) // acent tetrahedron, operate on the face only if the current tetrahedron // has a smaller pointer than its neighbor. This way, each face is // considered only once. - while (tface.tet != (tetrahedron *) NULL) { + while (tface.tet != (tetrahedron *) nullptr) { for (tface.loc = 0; tface.loc < 4; tface.loc ++) { sym(tface, tsymface); if ((tface.tet < tsymface.tet) || (tsymface.tet == dummytet)) { @@ -33230,7 +33230,7 @@ void tetgenmesh::outmesh2vtk(char* ofilename) int NEL = tetrahedrons->items; int NN = points->items; - if (ofilename != (char *) NULL && ofilename[0] != '\0') { + if (ofilename != (char *) nullptr && ofilename[0] != '\0') { strcpy(vtkfilename, ofilename); } else if (b->outfilename[0] != '\0') { strcpy(vtkfilename, b->outfilename); @@ -33243,7 +33243,7 @@ void tetgenmesh::outmesh2vtk(char* ofilename) printf("Writing %s.\n", vtkfilename); } outfile = fopen(vtkfilename, "w"); - if (outfile == (FILE *) NULL) { + if (outfile == (FILE *) nullptr) { printf("File I/O Error: Cannot create file %s.\n", vtkfilename); return; } @@ -33259,7 +33259,7 @@ void tetgenmesh::outmesh2vtk(char* ofilename) points->traversalinit(); pointloop = pointtraverse(); - for(int id=0; idtraversalinit(); tetraloop.tet = tetrahedrontraverse(); - while (tetraloop.tet != (tetrahedron *) NULL) { + while (tetraloop.tet != (tetrahedron *) nullptr) { // Check all four faces of the tetrahedron. for (tetraloop.loc = 0; tetraloop.loc < 4; tetraloop.loc++) { tetorg = org(tetraloop); @@ -33448,7 +33448,7 @@ int tetgenmesh::checkshells() // Run through the list of subfaces, checking each one. subfaces->traversalinit(); shloop.sh = shellfacetraverse(subfaces); - while (shloop.sh != (shellface *) NULL) { + while (shloop.sh != (shellface *) nullptr) { // Check two connected tetrahedra if they exist. shloop.shver = 0; stpivot(shloop, oppotet); @@ -33458,7 +33458,7 @@ int tetgenmesh::checkshells() pinfect((point) shloop.sh[3 + i]); } for (j = 0; j < 3; j++) { - if (org(oppotet) == NULL) break; + if (org(oppotet) == nullptr) break; if (!pinfected(org(oppotet))) break; enextself(oppotet); } @@ -33483,7 +33483,7 @@ int tetgenmesh::checkshells() printsh(&shloop); horrors++; } - if (oppo(oppotet) != (point) NULL) { + if (oppo(oppotet) != (point) nullptr) { adjustedgering(oppotet, CCW); checksign = orient3d(sorg(shloop), sdest(shloop), sapex(shloop), oppo(oppotet)); @@ -33520,7 +33520,7 @@ int tetgenmesh::checkshells() horrors++; } } - if (oppo(oppooppotet) != (point) NULL) { + if (oppo(oppooppotet) != (point) nullptr) { adjustedgering(oppooppotet, CCW); checksign = orient3d(sorg(shloop), sdest(shloop), sapex(shloop), oppo(oppooppotet)); @@ -33624,7 +33624,7 @@ int tetgenmesh::checkshells() // Run through the list of subsegs, checking each one. subsegs->traversalinit(); segloop.sh = shellfacetraverse(subsegs); - while (segloop.sh != (shellface *) NULL) { + while (segloop.sh != (shellface *) nullptr) { segorg = sorg(segloop); segdest = sdest(segloop); spivot(segloop, testsh); @@ -33714,9 +33714,9 @@ int tetgenmesh::checksegments() horrors = 0; tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != NULL) { + while (tetloop.tet != nullptr) { // Loop the six edges of the tet. - if (tetloop.tet[8] != NULL) { + if (tetloop.tet[8] != nullptr) { for (i = 0; i < 6; i++) { tetloop.loc = edge2locver[i][0]; tetloop.ver = edge2locver[i][1]; @@ -33747,7 +33747,7 @@ int tetgenmesh::checksegments() (unsigned long) tetloop.tet, pointmark(org(tetloop)), pointmark(dest(tetloop)), pointmark(apex(tetloop)), pointmark(oppo(tetloop))); - if (checkseg.sh != NULL) { + if (checkseg.sh != nullptr) { printf("Seg x%lx (%d, %d).\n", (unsigned long) checkseg.sh, pointmark(sorg(checkseg)), pointmark(sdest(checkseg))); } else { @@ -33806,7 +33806,7 @@ int tetgenmesh::checkdelaunay(REAL eps, queue* flipqueue) // Run through the list of triangles, checking each one. tetrahedrons->traversalinit(); tetraloop.tet = tetrahedrontraverse(); - while (tetraloop.tet != (tetrahedron *) NULL) { + while (tetraloop.tet != (tetrahedron *) nullptr) { // Check all four faces of the tetrahedron. for (tetraloop.loc = 0; tetraloop.loc < 4; tetraloop.loc++) { tetorg = org(tetraloop); @@ -33818,8 +33818,8 @@ int tetgenmesh::checkdelaunay(REAL eps, queue* flipqueue) // Only do testif there is an adjoining tetrahedron whose pointer is // larger (to ensure that each pair isn't tested twice). shouldbedelaunay = (oppotet.tet != dummytet) - && (tetoppo != (point) NULL) - && (oppooppo != (point) NULL) + && (tetoppo != (point) nullptr) + && (oppooppo != (point) nullptr) && (tetraloop.tet < oppotet.tet); if (checksubfaces && shouldbedelaunay) { // If a shell face separates the tetrahedra, then the face is @@ -33846,7 +33846,7 @@ int tetgenmesh::checkdelaunay(REAL eps, queue* flipqueue) tetraloop.tet = tetrahedrontraverse(); } - if (flipqueue == (queue *) NULL) { + if (flipqueue == (queue *) nullptr) { if (horrors == 0) { if (!b->quiet) { printf(" The mesh is %s.\n", @@ -33878,8 +33878,8 @@ void tetgenmesh::checkconforming() // Run through the list of subsegments, check each one. subsegs->traversalinit(); segloop.sh = shellfacetraverse(subsegs); - while (segloop.sh != (shellface *) NULL) { - if (checkseg4encroach(&segloop, NULL, NULL, false)) { + while (segloop.sh != (shellface *) nullptr) { + if (checkseg4encroach(&segloop, nullptr, nullptr, false)) { printf(" !! !! Non-conforming subsegment: (%d, %d)\n", pointmark(sorg(segloop)), pointmark(sdest(segloop))); encsubsegs++; @@ -33889,8 +33889,8 @@ void tetgenmesh::checkconforming() // Run through the list of subfaces, check each one. subfaces->traversalinit(); shloop.sh = shellfacetraverse(subfaces); - while (shloop.sh != (shellface *) NULL) { - if (checksub4encroach(&shloop, NULL, false)) { + while (shloop.sh != (shellface *) nullptr) { + if (checksub4encroach(&shloop, nullptr, false)) { printf(" !! !! Non-conforming subface: (%d, %d, %d)\n", pointmark(sorg(shloop)), pointmark(sdest(shloop)), pointmark(sapex(shloop))); @@ -34049,7 +34049,7 @@ void tetgenmesh::qualitystatistics() // Loop all elements, calculate quality parameters for each element. tetrahedrons->traversalinit(); tetloop.tet = tetrahedrontraverse(); - while (tetloop.tet != (tetrahedron *) NULL) { + while (tetloop.tet != (tetrahedron *) nullptr) { // Get four vertices: p0, p1, p2, p3. for (i = 0; i < 4; i++) p[i] = (point) tetloop.tet[4 + i]; @@ -34197,8 +34197,8 @@ void tetgenmesh::qualitystatistics() p[0] = org(tetloop); p[1] = dest(tetloop); p[2] = apex(tetloop); - faceangle[0] = interiorangle(p[0], p[1], p[2], NULL); - faceangle[1] = interiorangle(p[1], p[2], p[0], NULL); + faceangle[0] = interiorangle(p[0], p[1], p[2], nullptr); + faceangle[1] = interiorangle(p[1], p[2], p[0], nullptr); faceangle[2] = PI - (faceangle[0] + faceangle[1]); // Translate angles into degrees. for (i = 0; i < 3; i++) { @@ -34466,7 +34466,7 @@ void tetrahedralize(tetgenbehavior *b, tetgenio *in, tetgenio *out, } if (b->metric) { - if (bgmin != (tetgenio *) NULL) { + if (bgmin != (tetgenio *) nullptr) { m.bgm->initializepools(); m.bgm->transfernodes(); m.bgm->reconstructmesh(); @@ -34555,7 +34555,7 @@ void tetrahedralize(tetgenbehavior *b, tetgenio *in, tetgenio *out, } } - if (b->insertaddpoints && (addin != (tetgenio *) NULL)) { + if (b->insertaddpoints && (addin != (tetgenio *) nullptr)) { if (addin->numberofpoints > 0) { m.insertconstrainedpoints(addin); } @@ -34635,7 +34635,7 @@ void tetrahedralize(tetgenbehavior *b, tetgenio *in, tetgenio *out, printf("\n"); } - if (out != (tetgenio *) NULL) { + if (out != (tetgenio *) nullptr) { out->firstnumber = in->firstnumber; out->mesh_dim = in->mesh_dim; } @@ -34754,7 +34754,7 @@ void tetrahedralize(tetgenbehavior *b, tetgenio *in, tetgenio *out, m.checkshells(); } if (b->docheck > 1) { - if (m.checkdelaunay(0.0, NULL) > 0) { + if (m.checkdelaunay(0.0, nullptr) > 0) { assert(0); } if (b->docheck > 2) { diff --git a/applications/MeshingApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.h b/applications/MeshingApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.h index 2b7eb9a48271..cb245f77b17d 100644 --- a/applications/MeshingApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.h +++ b/applications/MeshingApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.h @@ -223,7 +223,7 @@ class tetgenio static void init(polygon* p) { - p->vertexlist = (int *) NULL; + p->vertexlist = (int *) nullptr; p->numberofvertices = 0; } @@ -239,9 +239,9 @@ class tetgenio static void init(facet* f) { - f->polygonlist = (polygon *) NULL; + f->polygonlist = (polygon *) nullptr; f->numberofpolygons = 0; - f->holelist = (REAL *) NULL; + f->holelist = (REAL *) nullptr; f->numberofholes = 0; } @@ -448,59 +448,59 @@ class tetgenio mesh_dim = 3; // Default mesh dimension is 3. useindex = true; - pointlist = (REAL *) NULL; - pointattributelist = (REAL *) NULL; - pointmtrlist = (REAL *) NULL; - pointmarkerlist = (int *) NULL; + pointlist = (REAL *) nullptr; + pointattributelist = (REAL *) nullptr; + pointmtrlist = (REAL *) nullptr; + pointmarkerlist = (int *) nullptr; numberofpoints = 0; numberofpointattributes = 0; numberofpointmtrs = 0; - tetrahedronlist = (int *) NULL; - tetrahedronattributelist = (REAL *) NULL; - tetrahedronvolumelist = (REAL *) NULL; - neighborlist = (int *) NULL; + tetrahedronlist = (int *) nullptr; + tetrahedronattributelist = (REAL *) nullptr; + tetrahedronvolumelist = (REAL *) nullptr; + neighborlist = (int *) nullptr; numberoftetrahedra = 0; numberofcorners = 4; // Default is 4 nodes per element. numberoftetrahedronattributes = 0; - trifacelist = (int *) NULL; - adjtetlist = (int *) NULL; - trifacemarkerlist = (int *) NULL; + trifacelist = (int *) nullptr; + adjtetlist = (int *) nullptr; + trifacemarkerlist = (int *) nullptr; numberoftrifaces = 0; - facetlist = (facet *) NULL; - facetmarkerlist = (int *) NULL; + facetlist = (facet *) nullptr; + facetmarkerlist = (int *) nullptr; numberoffacets = 0; - edgelist = (int *) NULL; - edgemarkerlist = (int *) NULL; + edgelist = (int *) nullptr; + edgemarkerlist = (int *) nullptr; numberofedges = 0; - holelist = (REAL *) NULL; + holelist = (REAL *) nullptr; numberofholes = 0; - regionlist = (REAL *) NULL; + regionlist = (REAL *) nullptr; numberofregions = 0; - facetconstraintlist = (REAL *) NULL; + facetconstraintlist = (REAL *) nullptr; numberoffacetconstraints = 0; - segmentconstraintlist = (REAL *) NULL; + segmentconstraintlist = (REAL *) nullptr; numberofsegmentconstraints = 0; - pbcgrouplist = (pbcgroup *) NULL; + pbcgrouplist = (pbcgroup *) nullptr; numberofpbcgroups = 0; - vpointlist = (REAL *) NULL; - vedgelist = (voroedge *) NULL; - vfacetlist = (vorofacet *) NULL; - vcelllist = (int **) NULL; + vpointlist = (REAL *) nullptr; + vedgelist = (voroedge *) nullptr; + vfacetlist = (vorofacet *) nullptr; + vcelllist = (int **) nullptr; numberofvpoints = 0; numberofvedges = 0; numberofvfacets = 0; numberofvcells = 0; - tetunsuitable = NULL; + tetunsuitable = nullptr; } // Free the memory allocated in 'tetgenio'. @@ -514,63 +514,63 @@ class tetgenio // This routine assumes that the memory was allocated by // C++ memory allocation operator 'new'. - if (pointlist != (REAL *) NULL) + if (pointlist != (REAL *) nullptr) { delete [] pointlist; } - if (pointattributelist != (REAL *) NULL) + if (pointattributelist != (REAL *) nullptr) { delete [] pointattributelist; } - if (pointmtrlist != (REAL *) NULL) + if (pointmtrlist != (REAL *) nullptr) { delete [] pointmtrlist; } - if (pointmarkerlist != (int *) NULL) + if (pointmarkerlist != (int *) nullptr) { delete [] pointmarkerlist; } - if (tetrahedronlist != (int *) NULL) + if (tetrahedronlist != (int *) nullptr) { delete [] tetrahedronlist; } - if (tetrahedronattributelist != (REAL *) NULL) + if (tetrahedronattributelist != (REAL *) nullptr) { delete [] tetrahedronattributelist; } - if (tetrahedronvolumelist != (REAL *) NULL) + if (tetrahedronvolumelist != (REAL *) nullptr) { delete [] tetrahedronvolumelist; } - if (neighborlist != (int *) NULL) + if (neighborlist != (int *) nullptr) { delete [] neighborlist; } - if (trifacelist != (int *) NULL) + if (trifacelist != (int *) nullptr) { delete [] trifacelist; } - if (adjtetlist != (int *) NULL) + if (adjtetlist != (int *) nullptr) { delete [] adjtetlist; } - if (trifacemarkerlist != (int *) NULL) + if (trifacemarkerlist != (int *) nullptr) { delete [] trifacemarkerlist; } - if (edgelist != (int *) NULL) + if (edgelist != (int *) nullptr) { delete [] edgelist; } - if (edgemarkerlist != (int *) NULL) + if (edgemarkerlist != (int *) nullptr) { delete [] edgemarkerlist; } - if (facetlist != (facet *) NULL) + if (facetlist != (facet *) nullptr) { for (i = 0; i < numberoffacets; i++) { @@ -581,55 +581,55 @@ class tetgenio delete [] p->vertexlist; } delete [] f->polygonlist; - if (f->holelist != (REAL *) NULL) + if (f->holelist != (REAL *) nullptr) { delete [] f->holelist; } } delete [] facetlist; } - if (facetmarkerlist != (int *) NULL) + if (facetmarkerlist != (int *) nullptr) { delete [] facetmarkerlist; } - if (holelist != (REAL *) NULL) + if (holelist != (REAL *) nullptr) { delete [] holelist; } - if (regionlist != (REAL *) NULL) + if (regionlist != (REAL *) nullptr) { delete [] regionlist; } - if (facetconstraintlist != (REAL *) NULL) + if (facetconstraintlist != (REAL *) nullptr) { delete [] facetconstraintlist; } - if (segmentconstraintlist != (REAL *) NULL) + if (segmentconstraintlist != (REAL *) nullptr) { delete [] segmentconstraintlist; } - if (pbcgrouplist != (pbcgroup *) NULL) + if (pbcgrouplist != (pbcgroup *) nullptr) { for (i = 0; i < numberofpbcgroups; i++) { pg = &(pbcgrouplist[i]); - if (pg->pointpairlist != (int *) NULL) + if (pg->pointpairlist != (int *) nullptr) { delete [] pg->pointpairlist; } } delete [] pbcgrouplist; } - if (vpointlist != (REAL *) NULL) + if (vpointlist != (REAL *) nullptr) { delete [] vpointlist; } - if (vedgelist != (voroedge *) NULL) + if (vedgelist != (voroedge *) nullptr) { delete [] vedgelist; } - if (vfacetlist != (vorofacet *) NULL) + if (vfacetlist != (vorofacet *) nullptr) { for (i = 0; i < numberofvfacets; i++) { @@ -637,7 +637,7 @@ class tetgenio } delete [] vfacetlist; } - if (vcelllist != (int **) NULL) + if (vcelllist != (int **) nullptr) { for (i = 0; i < numberofvcells; i++) { @@ -834,8 +834,7 @@ class tetgenbehavior } ~tetgenbehavior() - { - } + = default; }; /////////////////////////////////////////////////////////////////////////////// @@ -1099,15 +1098,10 @@ class tetgenmesh int loc, ver; // Constructors; - triface() : tet(0), loc(0), ver(0) {} + triface() : tet(nullptr), loc(0), ver(0) {} // Operators; triface& operator=(const triface& t) - { - tet = t.tet; - loc = t.loc; - ver = t.ver; - return *this; - } + = default; bool operator==(triface& t) { return tet == t.tet && loc == t.loc && ver == t.ver; @@ -1127,14 +1121,10 @@ class tetgenmesh int shver; // Constructors; - face() : sh(0), shver(0) {} + face() : sh(nullptr), shver(0) {} // Operators; face& operator=(const face& s) - { - sh = s.sh; - shver = s.shver; - return *this; - } + = default; bool operator==(face& s) { return (sh == s.sh) && (shver == s.shver); @@ -1201,8 +1191,8 @@ class tetgenmesh elemflip() { ft = T23; // Default. - pset1[0] = pset1[1] = pset1[2] = (point) NULL; - pset2[0] = pset2[1] = pset2[2] = (point) NULL; + pset1[0] = pset1[1] = pset1[2] = (point) nullptr; + pset2[0] = pset2[1] = pset2[2] = (point) nullptr; } }; @@ -1654,7 +1644,7 @@ class tetgenmesh head = (void **) alloc(); tail = (void **) alloc(); *head = (void *) tail; - *tail = NULL; + *tail = nullptr; linkitems = 0; } @@ -1666,7 +1656,7 @@ class tetgenmesh head = (void **) alloc(); tail = (void **) alloc(); *head = (void *) tail; - *tail = NULL; + *tail = nullptr; linkitems = 0; } @@ -1682,12 +1672,12 @@ class tetgenmesh void *push(void* newitem) { void **newnode = tail; - if (newitem != (void *) NULL) + if (newitem != (void *) nullptr) { memcpy((void *)(newnode + 1), newitem, linkitembytes); } tail = (void **) alloc(); - *tail = NULL; + *tail = nullptr; *newnode = (void *) tail; linkitems++; return (void *)(newnode + 1); @@ -1705,7 +1695,7 @@ class tetgenmesh } else { - return NULL; + return nullptr; } } }; @@ -2286,43 +2276,43 @@ class tetgenmesh tetgenmesh() { - bgm = (tetgenmesh *) NULL; - in = (tetgenio *) NULL; - b = (tetgenbehavior *) NULL; - - tetrahedrons = (memorypool *) NULL; - subfaces = (memorypool *) NULL; - subsegs = (memorypool *) NULL; - points = (memorypool *) NULL; - badsubsegs = (memorypool *) NULL; - badsubfaces = (memorypool *) NULL; - badtetrahedrons = (memorypool *) NULL; - tet2segpool = NULL; - tet2subpool = NULL; - - dummytet = (tetrahedron *) NULL; - dummytetbase = (tetrahedron *) NULL; - dummysh = (shellface *) NULL; - dummyshbase = (shellface *) NULL; - - facetabovepointarray = (point *) NULL; - abovepoint = (point) NULL; - dummypoint = NULL; - btreenode_list = (arraypool *) NULL; - highordertable = (point *) NULL; - subpbcgrouptable = (pbcdata *) NULL; - segpbcgrouptable = (list *) NULL; - idx2segpglist = (int *) NULL; - segpglist = (int *) NULL; - - cavetetlist = NULL; - cavebdrylist = NULL; - caveoldtetlist = NULL; - caveshlist = caveshbdlist = NULL; - subsegstack = subfacstack = NULL; - - elemfliplist = (arraypool *) NULL; - fixededgelist = (arraypool *) NULL; + bgm = (tetgenmesh *) nullptr; + in = (tetgenio *) nullptr; + b = (tetgenbehavior *) nullptr; + + tetrahedrons = (memorypool *) nullptr; + subfaces = (memorypool *) nullptr; + subsegs = (memorypool *) nullptr; + points = (memorypool *) nullptr; + badsubsegs = (memorypool *) nullptr; + badsubfaces = (memorypool *) nullptr; + badtetrahedrons = (memorypool *) nullptr; + tet2segpool = nullptr; + tet2subpool = nullptr; + + dummytet = (tetrahedron *) nullptr; + dummytetbase = (tetrahedron *) nullptr; + dummysh = (shellface *) nullptr; + dummyshbase = (shellface *) nullptr; + + facetabovepointarray = (point *) nullptr; + abovepoint = (point) nullptr; + dummypoint = nullptr; + btreenode_list = (arraypool *) nullptr; + highordertable = (point *) nullptr; + subpbcgrouptable = (pbcdata *) nullptr; + segpbcgrouptable = (list *) nullptr; + idx2segpglist = (int *) nullptr; + segpglist = (int *) nullptr; + + cavetetlist = nullptr; + cavebdrylist = nullptr; + caveoldtetlist = nullptr; + caveshlist = caveshbdlist = nullptr; + subsegstack = subfacstack = nullptr; + + elemfliplist = (arraypool *) nullptr; + fixededgelist = (arraypool *) nullptr; xmax = xmin = ymax = ymin = zmax = zmin = 0.0; longest = 0.0; @@ -2382,76 +2372,76 @@ class tetgenmesh ~tetgenmesh() { - bgm = (tetgenmesh *) NULL; - in = (tetgenio *) NULL; - b = (tetgenbehavior *) NULL; + bgm = (tetgenmesh *) nullptr; + in = (tetgenio *) nullptr; + b = (tetgenbehavior *) nullptr; - if (tetrahedrons != (memorypool *) NULL) + if (tetrahedrons != (memorypool *) nullptr) { delete tetrahedrons; } - if (subfaces != (memorypool *) NULL) + if (subfaces != (memorypool *) nullptr) { delete subfaces; } - if (subsegs != (memorypool *) NULL) + if (subsegs != (memorypool *) nullptr) { delete subsegs; } - if (points != (memorypool *) NULL) + if (points != (memorypool *) nullptr) { delete points; } - if (tet2segpool != NULL) + if (tet2segpool != nullptr) { delete tet2segpool; } - if (tet2subpool != NULL) + if (tet2subpool != nullptr) { delete tet2subpool; } - if (dummytetbase != (tetrahedron *) NULL) + if (dummytetbase != (tetrahedron *) nullptr) { delete [] dummytetbase; } - if (dummyshbase != (shellface *) NULL) + if (dummyshbase != (shellface *) nullptr) { delete [] dummyshbase; } - if (facetabovepointarray != (point *) NULL) + if (facetabovepointarray != (point *) nullptr) { delete [] facetabovepointarray; } - if (dummypoint != NULL) + if (dummypoint != nullptr) { delete [] dummypoint; } - if (highordertable != (point *) NULL) + if (highordertable != (point *) nullptr) { delete [] highordertable; } - if (subpbcgrouptable != (pbcdata *) NULL) + if (subpbcgrouptable != (pbcdata *) nullptr) { delete [] subpbcgrouptable; } - if (segpbcgrouptable != (list *) NULL) + if (segpbcgrouptable != (list *) nullptr) { delete segpbcgrouptable; delete [] idx2segpglist; delete [] segpglist; } - if (cavetetlist != NULL) + if (cavetetlist != nullptr) { delete cavetetlist; delete cavebdrylist; delete caveoldtetlist; } - if (subsegstack != NULL) + if (subsegstack != nullptr) { delete subsegstack; } - if (subfacstack != NULL) + if (subfacstack != nullptr) { delete subfacstack; } @@ -2475,11 +2465,11 @@ class tetgenmesh /////////////////////////////////////////////////////////////////////////////// void tetrahedralize(tetgenbehavior *b, tetgenio *in, tetgenio *out, - tetgenio *addin = NULL, tetgenio *bgmin = NULL); + tetgenio *addin = nullptr, tetgenio *bgmin = nullptr); #ifdef TETLIBRARY void tetrahedralize(char *switches, tetgenio *in, tetgenio *out, - tetgenio *addin = NULL, tetgenio *bgmin = NULL); + tetgenio *addin = nullptr, tetgenio *bgmin = nullptr); #endif // #ifdef TETLIBRARY /////////////////////////////////////////////////////////////////////////////// @@ -3188,7 +3178,7 @@ inline void tetgenmesh::sfnext(face& s1, face& s2) inline void tetgenmesh::sfnextself(face& s) { - getnextsface(&s, NULL); + getnextsface(&s, nullptr); } // These primitives read or set a pointer of the badface structure. The @@ -3305,7 +3295,7 @@ inline bool tetgenmesh::sinfected(face& s) inline void tetgenmesh::tspivot(triface& t, face& s) { - if ((t).tet[9] != NULL) + if ((t).tet[9] != nullptr) { sdecode(((shellface *) (t).tet[9])[(t).loc], s); } @@ -3329,7 +3319,7 @@ inline void tetgenmesh::stpivot(face& s, triface& t) inline void tetgenmesh::tsbond(triface& t, face& s) { - if ((t).tet[9] == NULL) + if ((t).tet[9] == nullptr) { // Allocate space for this tet. (t).tet[9] = (tetrahedron) tet2subpool->alloc(); @@ -3349,7 +3339,7 @@ inline void tetgenmesh::tsbond(triface& t, face& s) inline void tetgenmesh::tsdissolve(triface& t) { - if ((t).tet[9] != NULL) + if ((t).tet[9] != nullptr) { ((shellface *) (t).tet[9])[(t).loc] = (shellface) dummysh; } @@ -3404,7 +3394,7 @@ inline void tetgenmesh::ssdissolve(face& s) inline void tetgenmesh::tsspivot1(triface& t, face& s) { - if ((t).tet[8] != NULL) + if ((t).tet[8] != nullptr) { sdecode(((shellface *) (t).tet[8])[locver2edge[(t).loc][(t).ver]], s); } @@ -3420,7 +3410,7 @@ inline void tetgenmesh::tsspivot1(triface& t, face& s) inline void tetgenmesh::tssbond1(triface& t, face& s) { - if ((t).tet[8] == NULL) + if ((t).tet[8] == nullptr) { // Allocate space for this tet. (t).tet[8] = (tetrahedron) tet2segpool->alloc(); @@ -3437,7 +3427,7 @@ inline void tetgenmesh::tssbond1(triface& t, face& s) inline void tetgenmesh::tssdissolve1(triface& t) { - if ((t).tet[8] != NULL) + if ((t).tet[8] != nullptr) { ((shellface *) (t).tet[8])[locver2edge[(t).loc][(t).ver]] = (shellface) dummysh; @@ -3592,14 +3582,14 @@ inline void tetgenmesh::adjustedgering(face& s, int direction) inline bool tetgenmesh::isdead(triface* t) { - if (t->tet == (tetrahedron *) NULL) return true; - else return t->tet[4] == (tetrahedron) NULL; + if (t->tet == (tetrahedron *) nullptr) return true; + else return t->tet[4] == (tetrahedron) nullptr; } inline bool tetgenmesh::isdead(face* s) { - if (s->sh == (shellface *) NULL) return true; - else return s->sh[3] == (shellface) NULL; + if (s->sh == (shellface *) nullptr) return true; + else return s->sh[3] == (shellface) nullptr; } // isfacehaspoint() returns TRUE if the 'testpoint' is one of the vertices diff --git a/applications/MeshingApplication/custom_processes/internal_variables_interpolation_process.h b/applications/MeshingApplication/custom_processes/internal_variables_interpolation_process.h index 44ea371aa9e0..28871d4865b4 100755 --- a/applications/MeshingApplication/custom_processes/internal_variables_interpolation_process.h +++ b/applications/MeshingApplication/custom_processes/internal_variables_interpolation_process.h @@ -1,4 +1,3 @@ -#include // KRATOS __ __ _____ ____ _ _ ___ _ _ ____ // | \/ | ____/ ___|| | | |_ _| \ | |/ ___| // | |\/| | _| \___ \| |_| || || \| | | _ @@ -88,21 +87,16 @@ class GaussPointItem ConstitutiveLaw::Pointer pConstitutiveLaw, const double Weight ):Point<3>(Coords), - mpConstitutiveLaw(pConstitutiveLaw), + mpConstitutiveLaw(std::move(pConstitutiveLaw)), mWeight(Weight) { } ///Copy constructor (not really required) - GaussPointItem(const GaussPointItem& GP): - Point<3>(GP), - mpConstitutiveLaw(GP.mpConstitutiveLaw), - mWeight(GP.mWeight) - { - } + GaussPointItem(const GaussPointItem& GP)= default; /// Destructor. - ~GaussPointItem(){} + ~GaussPointItem() override= default; ///@} ///@name Operators @@ -159,7 +153,7 @@ class GaussPointItem * @return mWeight: The pointer to the Constitutive Law associated to the point */ - double GetWeight() + double GetWeight() const { return mWeight; } @@ -169,7 +163,7 @@ class GaussPointItem * @param Weight: The integration weight */ - void SetWeight(double Weight) + void SetWeight(const double Weight) { mWeight = Weight; } @@ -314,11 +308,11 @@ class InternalVariablesInterpolationProcess if (ThisParameters["internal_variable_interpolation_list"].IsArray() == true) { - auto VariableArrayList = ThisParameters["internal_variable_interpolation_list"]; + auto variable_array_list = ThisParameters["internal_variable_interpolation_list"]; - for (unsigned int iVar = 0; iVar < VariableArrayList.size(); iVar++) + for (auto && i_var : variable_array_list) { - mInternalVariableList.push_back(KratosComponents>::Get(VariableArrayList[iVar].GetString())); + mInternalVariableList.push_back(KratosComponents>::Get(i_var.GetString())); } } else @@ -328,7 +322,7 @@ class InternalVariablesInterpolationProcess } } - virtual ~InternalVariablesInterpolationProcess(){}; + ~InternalVariablesInterpolationProcess() override= default;; ///@} ///@name Operators @@ -347,7 +341,7 @@ class InternalVariablesInterpolationProcess * We execute the search relative to the old and new model part */ - virtual void Execute() + void Execute() override { /** NOTE: There are mainly two ways to interpolate the internal variables (there are three, but just two are behave correctly) * CPT: Closest point transfer. It transfer the values from the closest GP @@ -384,7 +378,7 @@ class InternalVariablesInterpolationProcess /************************************ GET INFO *************************************/ /***********************************************************************************/ - virtual std::string Info() const + std::string Info() const override { return "InternalVariablesInterpolationProcess"; } @@ -392,7 +386,7 @@ class InternalVariablesInterpolationProcess /************************************ PRINT INFO ***********************************/ /***********************************************************************************/ - virtual void PrintInfo(std::ostream& rOStream) const + void PrintInfo(std::ostream& rOStream) const override { rOStream << Info(); } @@ -475,73 +469,73 @@ class InternalVariablesInterpolationProcess PointVector CreateGaussPointList(ModelPart& ThisModelPart) { - PointVector ThisPointVector; + PointVector this_point_vector; - GeometryData::IntegrationMethod ThisIntegrationMethod; + GeometryData::IntegrationMethod this_integration_method; // Iterate in the elements - ElementsArrayType& pElements = ThisModelPart.Elements(); - int numElements = ThisModelPart.NumberOfElements(); + ElementsArrayType& p_elements = ThisModelPart.Elements(); + int num_elements = ThisModelPart.NumberOfElements(); - const ProcessInfo& CurrentProcessInfo = ThisModelPart.GetProcessInfo(); + const ProcessInfo& current_process_info = ThisModelPart.GetProcessInfo(); // Creating a buffer for parallel vector fill - const unsigned int NumThreads = omp_get_max_threads(); - std::vector PointsBuffers(NumThreads); + const unsigned int num_threads = omp_get_max_threads(); + std::vector points_buffer(num_threads); #pragma omp parallel { const unsigned int Id = omp_get_thread_num(); #pragma omp for - for(int i = 0; i < numElements; i++) + for(int i = 0; i < num_elements; i++) { - auto itElem = pElements.begin() + i; + auto it_elem = p_elements.begin() + i; // Getting the geometry - Element::GeometryType& rThisGeometry = itElem->GetGeometry(); + Element::GeometryType& r_this_geometry = it_elem->GetGeometry(); // Getting the integration points - ThisIntegrationMethod = itElem->GetIntegrationMethod(); - const Element::GeometryType::IntegrationPointsArrayType& IntegrationPoints = rThisGeometry.IntegrationPoints(ThisIntegrationMethod); - const unsigned int IntegrationPointsNumber = IntegrationPoints.size(); + this_integration_method = it_elem->GetIntegrationMethod(); + const Element::GeometryType::IntegrationPointsArrayType& integration_points = r_this_geometry.IntegrationPoints(this_integration_method); + const unsigned int integration_points_number = integration_points.size(); // Computing the Jacobian - Vector VectorDetJ(IntegrationPointsNumber); - rThisGeometry.DeterminantOfJacobian(VectorDetJ,ThisIntegrationMethod); + Vector vector_det_j(integration_points_number); + r_this_geometry.DeterminantOfJacobian(vector_det_j,this_integration_method); // Getting the CL - std::vector ConstitutiveLawVector(IntegrationPointsNumber); - itElem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,ConstitutiveLawVector,CurrentProcessInfo); + std::vector constitutive_law_vector(integration_points_number); + it_elem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,constitutive_law_vector,current_process_info); - for (unsigned int iGaussPoint = 0; iGaussPoint < IntegrationPointsNumber; iGaussPoint++ ) + for (unsigned int i_gauss_point = 0; i_gauss_point < integration_points_number; i_gauss_point++ ) { - const array_1d LocalCoordinates = IntegrationPoints[iGaussPoint].Coordinates(); + const array_1d local_coordinates = integration_points[i_gauss_point].Coordinates(); // We compute the corresponding weight - const double Weight = VectorDetJ[iGaussPoint] * IntegrationPoints[iGaussPoint].Weight(); + const double weight = vector_det_j[i_gauss_point] * integration_points[i_gauss_point].Weight(); // We compute the global coordinates - array_1d GlobalCoordinates; - GlobalCoordinates = rThisGeometry.GlobalCoordinates( GlobalCoordinates, LocalCoordinates ); + array_1d global_coordinates; + global_coordinates = r_this_geometry.GlobalCoordinates( global_coordinates, local_coordinates ); // We create the respective GP - PointTypePointer pPoint = PointTypePointer(new PointType(GlobalCoordinates, ConstitutiveLawVector[iGaussPoint], Weight)); - (PointsBuffers[Id]).push_back(pPoint); + PointTypePointer p_point = PointTypePointer(new PointType(global_coordinates, constitutive_law_vector[i_gauss_point], weight)); + (points_buffer[Id]).push_back(p_point); } } // Combine buffers together #pragma omp single { - for( auto& PointsBuffer : PointsBuffers) + for( auto& point_buffer : points_buffer) { - std::move(PointsBuffer.begin(),PointsBuffer.end(),back_inserter(ThisPointVector)); + std::move(point_buffer.begin(),point_buffer.end(),back_inserter(this_point_vector)); } } } - return ThisPointVector; + return this_point_vector; } /** @@ -551,7 +545,7 @@ class InternalVariablesInterpolationProcess void InterpolateGaussPointsCPT() { // We Initialize the process info - const ProcessInfo& CurrentProcessInfo = mrDestinationMainModelPart.GetProcessInfo(); + const ProcessInfo& current_process_info = mrDestinationMainModelPart.GetProcessInfo(); // We update the list of points mPointListOrigin.clear(); @@ -560,51 +554,49 @@ class InternalVariablesInterpolationProcess //#pragma omp parallel firstprivate(mPointListOrigin) //{ // We initialize the intergration method - GeometryData::IntegrationMethod ThisIntegrationMethod; + GeometryData::IntegrationMethod this_integration_method; // Create a tree // It will use a copy of mNodeList (a std::vector which contains pointers) // Copying the list is required because the tree will reorder it for efficiency - KDTree TreePoints(mPointListOrigin.begin(), mPointListOrigin.end(), mBucketSize); + KDTree tree_points(mPointListOrigin.begin(), mPointListOrigin.end(), mBucketSize); // Iterate over the destination elements - ElementsArrayType& pElements = mrDestinationMainModelPart.Elements(); - auto numElements = pElements.end() - pElements.begin(); + ElementsArrayType& p_elements = mrDestinationMainModelPart.Elements(); + auto num_elements = p_elements.end() - p_elements.begin(); //#pragma omp for - for(int i = 0; i < numElements; i++) + for(int i = 0; i < num_elements; i++) { - auto itElem = pElements.begin() + i; + auto it_elem = p_elements.begin() + i; // Getting the geometry - Element::GeometryType& rThisGeometry = itElem->GetGeometry(); + Element::GeometryType& r_this_geometry = it_elem->GetGeometry(); // Getting the integration points - ThisIntegrationMethod = itElem->GetIntegrationMethod(); - const Element::GeometryType::IntegrationPointsArrayType& IntegrationPoints = rThisGeometry.IntegrationPoints(ThisIntegrationMethod); - const unsigned int IntegrationPointsNumber = IntegrationPoints.size(); + this_integration_method = it_elem->GetIntegrationMethod(); + const Element::GeometryType::IntegrationPointsArrayType& integration_points = r_this_geometry.IntegrationPoints(this_integration_method); + const unsigned int integration_points_number = integration_points.size(); // Getting the CL - std::vector ConstitutiveLawVector(IntegrationPointsNumber); - itElem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,ConstitutiveLawVector,CurrentProcessInfo); + std::vector constitutive_law_vector(integration_points_number); + it_elem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,constitutive_law_vector,current_process_info); - for (unsigned int iGaussPoint = 0; iGaussPoint < IntegrationPointsNumber; iGaussPoint++ ) + for (unsigned int i_gauss_point = 0; i_gauss_point < integration_points_number; i_gauss_point++ ) { // We compute the global coordinates - const array_1d LocalCoordinates = IntegrationPoints[iGaussPoint].Coordinates(); - array_1d GlobalCoordinates; - GlobalCoordinates = rThisGeometry.GlobalCoordinates( GlobalCoordinates, LocalCoordinates ); + const array_1d local_coordinates = integration_points[i_gauss_point].Coordinates(); + array_1d global_coordinates; + global_coordinates = r_this_geometry.GlobalCoordinates( global_coordinates, local_coordinates ); - PointTypePointer pGPOrigin = TreePoints.SearchNearestPoint(GlobalCoordinates); + PointTypePointer p_gp_origin = tree_points.SearchNearestPoint(global_coordinates); - for (unsigned int iVar = 0; iVar < mInternalVariableList.size(); iVar++) + for (auto this_var : mInternalVariableList) { - Variable ThisVar = mInternalVariableList[iVar]; + double origin_value; + origin_value = (p_gp_origin->GetConstitutiveLaw())->GetValue(this_var, origin_value); - double OriginValue; - OriginValue = (pGPOrigin->GetConstitutiveLaw())->GetValue(ThisVar, OriginValue); - - (ConstitutiveLawVector[iGaussPoint])->SetValue(ThisVar, OriginValue, CurrentProcessInfo); + (constitutive_law_vector[i_gauss_point])->SetValue(this_var, origin_value, current_process_info); } } } @@ -618,7 +610,7 @@ class InternalVariablesInterpolationProcess void InterpolateGaussPointsLST() { // We Initialize the process info - const ProcessInfo& CurrentProcessInfo = mrDestinationMainModelPart.GetProcessInfo(); + const ProcessInfo& current_process_info = mrDestinationMainModelPart.GetProcessInfo(); // We update the list of points mPointListOrigin.clear(); @@ -627,95 +619,93 @@ class InternalVariablesInterpolationProcess //#pragma omp parallel firstprivate(mPointListOrigin) //{ // We initialize the intergration method - GeometryData::IntegrationMethod ThisIntegrationMethod; + GeometryData::IntegrationMethod this_integration_method; // Initialize values - PointVector PointsFound(mAllocationSize); - std::vector PointsDistances(mAllocationSize); - unsigned int NumberPointsFound = 0; + PointVector points_found(mAllocationSize); + std::vector point_distnaces(mAllocationSize); + unsigned int number_points_found = 0; // Create a tree // It will use a copy of mNodeList (a std::vector which contains pointers) // Copying the list is required because the tree will reorder it for efficiency - KDTree TreePoints(mPointListOrigin.begin(), mPointListOrigin.end(), mBucketSize); + KDTree tree_points(mPointListOrigin.begin(), mPointListOrigin.end(), mBucketSize); // Iterate over the destination elements - ElementsArrayType& pElements = mrDestinationMainModelPart.Elements(); - auto numElements = pElements.end() - pElements.begin(); + ElementsArrayType& p_elements = mrDestinationMainModelPart.Elements(); + auto num_elements = p_elements.end() - p_elements.begin(); //#pragma omp for - for(int i = 0; i < numElements; i++) + for(int i = 0; i < num_elements; i++) { - auto itElem = pElements.begin() + i; + auto it_elem = p_elements.begin() + i; // Getting the geometry - Element::GeometryType& rThisGeometry = itElem->GetGeometry(); + Element::GeometryType& r_this_geometry = it_elem->GetGeometry(); // Getting the integration points - ThisIntegrationMethod = itElem->GetIntegrationMethod(); - const Element::GeometryType::IntegrationPointsArrayType& IntegrationPoints = rThisGeometry.IntegrationPoints(ThisIntegrationMethod); - const unsigned int IntegrationPointsNumber = IntegrationPoints.size(); + this_integration_method = it_elem->GetIntegrationMethod(); + const Element::GeometryType::IntegrationPointsArrayType& integration_points = r_this_geometry.IntegrationPoints(this_integration_method); + const unsigned int integration_points_number = integration_points.size(); // Getting the CL - std::vector ConstitutiveLawVector(IntegrationPointsNumber); - itElem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,ConstitutiveLawVector,CurrentProcessInfo); + std::vector constitutive_law_vector(integration_points_number); + it_elem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,constitutive_law_vector,current_process_info); // Computing the radius - const double Radius = mSearchFactor * (mDimension == 2 ? std::sqrt(rThisGeometry.Area()) : std::cbrt(rThisGeometry.Volume())); + const double radius = mSearchFactor * (mDimension == 2 ? std::sqrt(r_this_geometry.Area()) : std::cbrt(r_this_geometry.Volume())); // We get the NODAL_H vector - Vector NodalHVector(rThisGeometry.size()); - for (unsigned int iNode = 0; iNode < rThisGeometry.size(); iNode++) + Vector nodal_h_vector(r_this_geometry.size()); + for (unsigned int i_node = 0; i_node < r_this_geometry.size(); i_node++) { - if ( rThisGeometry[iNode].SolutionStepsDataHas( NODAL_H ) == false ) + if ( r_this_geometry[i_node].SolutionStepsDataHas( NODAL_H ) == false ) { - KRATOS_ERROR << "NODAL_H is not defined in the node ID: " << rThisGeometry[iNode].Id() << std::endl; + KRATOS_ERROR << "NODAL_H is not defined in the node ID: " << r_this_geometry[i_node].Id() << std::endl; } - NodalHVector[iNode] = rThisGeometry[iNode].FastGetSolutionStepValue(NODAL_H); + nodal_h_vector[i_node] = r_this_geometry[i_node].FastGetSolutionStepValue(NODAL_H); } - for (unsigned int iGaussPoint = 0; iGaussPoint < IntegrationPointsNumber; iGaussPoint++ ) + for (unsigned int i_gauss_point = 0; i_gauss_point < integration_points_number; i_gauss_point++ ) { // We compute the global coordinates - const array_1d LocalCoordinates = IntegrationPoints[iGaussPoint].Coordinates(); - array_1d GlobalCoordinates; - GlobalCoordinates = rThisGeometry.GlobalCoordinates( GlobalCoordinates, LocalCoordinates ); + const array_1d local_coordinates = integration_points[i_gauss_point].Coordinates(); + array_1d global_coordinates; + global_coordinates = r_this_geometry.GlobalCoordinates( global_coordinates, local_coordinates ); // We compute the pondered characteristic length - Vector N( rThisGeometry.size() ); - rThisGeometry.ShapeFunctionsValues( N, LocalCoordinates ); - const double CharacteristicLength = inner_prod(N, NodalHVector); + Vector N( r_this_geometry.size() ); + r_this_geometry.ShapeFunctionsValues( N, local_coordinates ); + const double characteristic_length = inner_prod(N, nodal_h_vector); - NumberPointsFound = TreePoints.SearchInRadius(GlobalCoordinates, Radius, PointsFound.begin(), PointsDistances.begin(), mAllocationSize); + number_points_found = tree_points.SearchInRadius(global_coordinates, radius, points_found.begin(), point_distnaces.begin(), mAllocationSize); - if (NumberPointsFound > 0) + if (number_points_found > 0) { - for (unsigned int iVar = 0; iVar < mInternalVariableList.size(); iVar++) + for (auto this_var : mInternalVariableList) { - Variable ThisVar = mInternalVariableList[iVar]; - - double WeightingFunctionNumerator = 0.0; - double WeightingFunctionDenominator = 0.0; - double OriginValue; + double weighting_function_numerator = 0.0; + double weighting_function_denominator = 0.0; + double origin_value; - for (unsigned int iPointFound = 0; iPointFound < NumberPointsFound; iPointFound++) + for (unsigned int i_point_found = 0; i_point_found < number_points_found; i_point_found++) { - PointTypePointer pGPOrigin = PointsFound[iPointFound]; + PointTypePointer p_gp_origin = points_found[i_point_found]; - const double Distance = PointsDistances[iPointFound]; + const double distance = point_distnaces[i_point_found]; - OriginValue = (pGPOrigin->GetConstitutiveLaw())->GetValue(ThisVar, OriginValue); + origin_value = (p_gp_origin->GetConstitutiveLaw())->GetValue(this_var, origin_value); - const double PonderatedWeight = pGPOrigin->GetWeight() * std::exp( -4.0 * Distance * Distance /(CharacteristicLength * CharacteristicLength)); + const double ponderated_weight = p_gp_origin->GetWeight() * std::exp( -4.0 * distance * distance /(characteristic_length * characteristic_length)); - WeightingFunctionNumerator += PonderatedWeight * OriginValue; - WeightingFunctionDenominator += PonderatedWeight; + weighting_function_numerator += ponderated_weight * origin_value; + weighting_function_denominator += ponderated_weight; } - const double DestinationValue = WeightingFunctionNumerator/WeightingFunctionDenominator; + const double destination_value = weighting_function_numerator/weighting_function_denominator; - (ConstitutiveLawVector[iGaussPoint])->SetValue(ThisVar, DestinationValue, CurrentProcessInfo); + (constitutive_law_vector[i_gauss_point])->SetValue(this_var, destination_value, current_process_info); } } else @@ -734,98 +724,92 @@ class InternalVariablesInterpolationProcess void InterpolateGaussPointsSFT() { // Initialize some values - GeometryData::IntegrationMethod ThisIntegrationMethod; + GeometryData::IntegrationMethod this_integration_method; // Iterate in the nodes to initialize the values - NodesArrayType& pNode = mrOriginMainModelPart.Nodes(); - auto numNodes = pNode.end() - pNode.begin(); + NodesArrayType& nodes_array = mrOriginMainModelPart.Nodes(); + auto num_nodes = nodes_array.end() - nodes_array.begin(); /* Nodes */ #pragma omp parallel for - for(int i = 0; i < numNodes; i++) + for(int i = 0; i < num_nodes; i++) { - auto itNode = pNode.begin() + i; + auto it_node = nodes_array.begin() + i; - for (unsigned int iVar = 0; iVar < mInternalVariableList.size(); iVar++) + for (auto this_var : mInternalVariableList) { - Variable ThisVar = mInternalVariableList[iVar]; - - itNode->SetValue(ThisVar, 0.0); + it_node->SetValue(this_var, 0.0); } } // Iterate in the elements to ponderate the values - ElementsArrayType& pElementsOrigin = mrOriginMainModelPart.Elements(); - auto numElements = pElementsOrigin.end() - pElementsOrigin.begin(); + ElementsArrayType& elements_array = mrOriginMainModelPart.Elements(); + auto num_elements = elements_array.end() - elements_array.begin(); - const ProcessInfo& OriginProcessInfo = mrOriginMainModelPart.GetProcessInfo(); + const ProcessInfo& origin_process_info = mrOriginMainModelPart.GetProcessInfo(); /* Elements */ #pragma omp parallel for - for(int i = 0; i < numElements; i++) + for(int i = 0; i < num_elements; i++) { - auto itElem = pElementsOrigin.begin() + i; + auto it_elem = elements_array.begin() + i; // Getting the geometry - Element::GeometryType& rThisGeometry = itElem->GetGeometry(); + Element::GeometryType& r_this_geometry = it_elem->GetGeometry(); // Getting the integration points - ThisIntegrationMethod = itElem->GetIntegrationMethod(); - const Element::GeometryType::IntegrationPointsArrayType& IntegrationPoints = rThisGeometry.IntegrationPoints(ThisIntegrationMethod); - const unsigned int IntegrationPointsNumber = IntegrationPoints.size(); + this_integration_method = it_elem->GetIntegrationMethod(); + const Element::GeometryType::IntegrationPointsArrayType& integration_points = r_this_geometry.IntegrationPoints(this_integration_method); + const unsigned int integration_points_number = integration_points.size(); // Computing the Jacobian - Vector VectorDetJ(IntegrationPointsNumber); - rThisGeometry.DeterminantOfJacobian(VectorDetJ,ThisIntegrationMethod); + Vector vector_det_j(integration_points_number); + r_this_geometry.DeterminantOfJacobian(vector_det_j,this_integration_method); // Getting the CL - std::vector ConstitutiveLawVector(IntegrationPointsNumber); - itElem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,ConstitutiveLawVector,OriginProcessInfo); + std::vector constitutive_law_vector(integration_points_number); + it_elem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,constitutive_law_vector,origin_process_info); // We initialize the total weigth - double TotalWeight = 0.0; + double total_weight = 0.0; - for (unsigned int iGaussPoint = 0; iGaussPoint < IntegrationPointsNumber; iGaussPoint++ ) + for (unsigned int i_gauss_point = 0; i_gauss_point < integration_points_number; i_gauss_point++ ) { - array_1d LocalCoordinates = IntegrationPoints[iGaussPoint].Coordinates(); + const array_1d local_coordinates = integration_points[i_gauss_point].Coordinates(); // We compute the corresponding weight - const double Weight = VectorDetJ[iGaussPoint] * IntegrationPoints[iGaussPoint].Weight(); - TotalWeight += Weight; + const double weight = vector_det_j[i_gauss_point] * integration_points[i_gauss_point].Weight(); + total_weight += weight; // We compute the pondered characteristic length - Vector N( rThisGeometry.size() ); - rThisGeometry.ShapeFunctionsValues( N, LocalCoordinates ); + Vector N( r_this_geometry.size() ); + r_this_geometry.ShapeFunctionsValues( N, local_coordinates ); // We compute the global coordinates - array_1d GlobalCoordinates; - GlobalCoordinates = rThisGeometry.GlobalCoordinates( GlobalCoordinates, LocalCoordinates ); + array_1d global_coordinates; + global_coordinates = r_this_geometry.GlobalCoordinates( global_coordinates, local_coordinates ); - for (unsigned int iVar = 0; iVar < mInternalVariableList.size(); iVar++) + for (auto this_var : mInternalVariableList) { - Variable ThisVar = mInternalVariableList[iVar]; - - double OriginValue; - OriginValue = ConstitutiveLawVector[iGaussPoint]->GetValue(ThisVar, OriginValue); + double origin_value; + origin_value = constitutive_law_vector[i_gauss_point]->GetValue(this_var, origin_value); // We sum all the contributions - for (unsigned int iNode = 0; iNode < rThisGeometry.size(); iNode++) + for (unsigned int i_node = 0; i_node < r_this_geometry.size(); i_node++) { #pragma omp atomic - rThisGeometry[iNode].GetValue(ThisVar) += N[iNode] * OriginValue * Weight; + r_this_geometry[i_node].GetValue(this_var) += N[i_node] * origin_value * weight; } } } // We divide by the total weight - for (unsigned int iVar = 0; iVar < mInternalVariableList.size(); iVar++) + for (auto this_var : mInternalVariableList) { - Variable ThisVar = mInternalVariableList[iVar]; - - for (unsigned int iNode = 0; iNode < rThisGeometry.size(); iNode++) + for (unsigned int i_node = 0; i_node < r_this_geometry.size(); i_node++) { #pragma omp critical - rThisGeometry[iNode].GetValue(ThisVar) /= TotalWeight; + r_this_geometry[i_node].GetValue(this_var) /= total_weight; } } } @@ -834,43 +818,41 @@ class InternalVariablesInterpolationProcess if (mDimension == 2) { // We create the locator - BinBasedFastPointLocator<2> PointLocator = BinBasedFastPointLocator<2>(mrOriginMainModelPart); - PointLocator.UpdateSearchDatabase(); + BinBasedFastPointLocator<2> point_locator = BinBasedFastPointLocator<2>(mrOriginMainModelPart); + point_locator.UpdateSearchDatabase(); // Iterate in the nodes - NodesArrayType& pNode = mrDestinationMainModelPart.Nodes(); - auto numNodes = pNode.end() - pNode.begin(); + NodesArrayType& nodes_array = mrDestinationMainModelPart.Nodes(); + auto num_nodes = nodes_array.end() - nodes_array.begin(); /* Nodes */ #pragma omp parallel for - for(int i = 0; i < numNodes; i++) + for(int i = 0; i < num_nodes; i++) { - auto itNode = pNode.begin() + i; + auto it_node = nodes_array.begin() + i; Vector N; - Element::Pointer pElement; + Element::Pointer p_element; - const bool found = PointLocator.FindPointOnMeshSimplified(itNode->Coordinates(), N, pElement, mAllocationSize); + const bool found = point_locator.FindPointOnMeshSimplified(it_node->Coordinates(), N, p_element, mAllocationSize); if (found == false) { std::cout << "WARNING: GP not found (interpolation not posible)" << std::endl; - std::cout << "\t X:"<< itNode->X() << "\t Y:"<< itNode->Y() << std::endl; + std::cout << "\t X:"<< it_node->X() << "\t Y:"<< it_node->Y() << std::endl; } else { - for (unsigned int iVar = 0; iVar < mInternalVariableList.size(); iVar++) + for (auto this_var : mInternalVariableList) { - Variable ThisVar = mInternalVariableList[iVar]; - - Vector Values(pElement->GetGeometry().size()); + Vector values(p_element->GetGeometry().size()); - for (unsigned int iNode = 0; iNode < pElement->GetGeometry().size(); iNode++) + for (unsigned int i_node = 0; i_node < p_element->GetGeometry().size(); i_node++) { - Values[iNode] = pElement->GetGeometry()[iNode].GetValue(ThisVar); + values[i_node] = p_element->GetGeometry()[i_node].GetValue(this_var); } - itNode->GetValue(ThisVar) = inner_prod(Values, N); + it_node->GetValue(this_var) = inner_prod(values, N); } } } @@ -878,98 +860,94 @@ class InternalVariablesInterpolationProcess else { // We create the locator - BinBasedFastPointLocator<3> PointLocator = BinBasedFastPointLocator<3>(mrOriginMainModelPart); - PointLocator.UpdateSearchDatabase(); + BinBasedFastPointLocator<3> point_locator = BinBasedFastPointLocator<3>(mrOriginMainModelPart); + point_locator.UpdateSearchDatabase(); // Iterate in the nodes - NodesArrayType& pNode = mrDestinationMainModelPart.Nodes(); - auto numNodes = pNode.end() - pNode.begin(); + NodesArrayType& nodes_array = mrDestinationMainModelPart.Nodes(); + auto num_nodes = nodes_array.end() - nodes_array.begin(); /* Nodes */ #pragma omp parallel for - for(int i = 0; i < numNodes; i++) + for(int i = 0; i < num_nodes; i++) { - auto itNode = pNode.begin() + i; + auto it_node = nodes_array.begin() + i; Vector N; - Element::Pointer pElement; + Element::Pointer p_element; - const bool found = PointLocator.FindPointOnMeshSimplified(itNode->Coordinates(), N, pElement, mAllocationSize); + const bool found = point_locator.FindPointOnMeshSimplified(it_node->Coordinates(), N, p_element, mAllocationSize); if (found == false) { - std::cout << "WARNING: Node "<< itNode->Id() << " not found (interpolation not posible)" << std::endl; - std::cout << "\t X:"<< itNode->X() << "\t Y:"<< itNode->Y() << "\t Z:"<< itNode->Z() << std::endl; + std::cout << "WARNING: Node "<< it_node->Id() << " not found (interpolation not posible)" << std::endl; + std::cout << "\t X:"<< it_node->X() << "\t Y:"<< it_node->Y() << "\t Z:"<< it_node->Z() << std::endl; } else { - for (unsigned int iVar = 0; iVar < mInternalVariableList.size(); iVar++) + for (auto this_var : mInternalVariableList) { - Variable ThisVar = mInternalVariableList[iVar]; + Vector values(p_element->GetGeometry().size()); - Vector Values(pElement->GetGeometry().size()); - - for (unsigned int iNode = 0; iNode < pElement->GetGeometry().size(); iNode++) + for (unsigned int i_node = 0; i_node < p_element->GetGeometry().size(); i_node++) { - Values[iNode] = pElement->GetGeometry()[iNode].GetValue(ThisVar); + values[i_node] = p_element->GetGeometry()[i_node].GetValue(this_var); } - itNode->GetValue(ThisVar) = inner_prod(Values, N); + it_node->GetValue(this_var) = inner_prod(values, N); } } } } // Finally we interpolate to the new GP - ElementsArrayType& pElementsDestination = mrDestinationMainModelPart.Elements(); - numElements = pElementsDestination.end() - pElementsDestination.begin(); + ElementsArrayType& p_elementsDestination = mrDestinationMainModelPart.Elements(); + num_elements = p_elementsDestination.end() - p_elementsDestination.begin(); - const ProcessInfo& DestinationProcessInfo = mrOriginMainModelPart.GetProcessInfo(); + const ProcessInfo& destination_process_info = mrOriginMainModelPart.GetProcessInfo(); /* Elements */ #pragma omp parallel for - for(int i = 0; i < numElements; i++) + for(int i = 0; i < num_elements; i++) { - auto itElem = pElementsDestination.begin() + i; + auto it_elem = p_elementsDestination.begin() + i; // Getting the geometry - Element::GeometryType& rThisGeometry = itElem->GetGeometry(); + Element::GeometryType& r_this_geometry = it_elem->GetGeometry(); // Getting the integration points - ThisIntegrationMethod = itElem->GetIntegrationMethod(); - const Element::GeometryType::IntegrationPointsArrayType& IntegrationPoints = rThisGeometry.IntegrationPoints(ThisIntegrationMethod); - const unsigned int IntegrationPointsNumber = IntegrationPoints.size(); + this_integration_method = it_elem->GetIntegrationMethod(); + const Element::GeometryType::IntegrationPointsArrayType& integration_points = r_this_geometry.IntegrationPoints(this_integration_method); + const unsigned int integration_points_number = integration_points.size(); // Getting the CL - std::vector ConstitutiveLawVector(IntegrationPointsNumber); - itElem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,ConstitutiveLawVector,DestinationProcessInfo); + std::vector constitutive_law_vector(integration_points_number); + it_elem->GetValueOnIntegrationPoints(CONSTITUTIVE_LAW,constitutive_law_vector,destination_process_info); - for (unsigned int iGaussPoint = 0; iGaussPoint < IntegrationPointsNumber; iGaussPoint++ ) + for (unsigned int i_gauss_point = 0; i_gauss_point < integration_points_number; i_gauss_point++ ) { - array_1d LocalCoordinates = IntegrationPoints[iGaussPoint].Coordinates(); + array_1d local_coordinates = integration_points[i_gauss_point].Coordinates(); // We compute the pondered characteristic length - Vector N( rThisGeometry.size() ); - rThisGeometry.ShapeFunctionsValues( N, LocalCoordinates ); + Vector N( r_this_geometry.size() ); + r_this_geometry.ShapeFunctionsValues( N, local_coordinates ); // We compute the global coordinates - array_1d GlobalCoordinates; - GlobalCoordinates = rThisGeometry.GlobalCoordinates( GlobalCoordinates, LocalCoordinates ); + array_1d global_coordinates; + global_coordinates = r_this_geometry.GlobalCoordinates( global_coordinates, local_coordinates ); - Vector Values(rThisGeometry.size() ); + Vector values(r_this_geometry.size() ); - for (unsigned int iVar = 0; iVar < mInternalVariableList.size(); iVar++) + for (auto this_var : mInternalVariableList) { - Variable ThisVar = mInternalVariableList[iVar]; - - for (unsigned int iNode = 0; iNode < rThisGeometry.size(); iNode++) + for (unsigned int i_node = 0; i_node < r_this_geometry.size(); i_node++) { - Values[iNode] = rThisGeometry[iNode].GetValue(ThisVar); + values[i_node] = r_this_geometry[i_node].GetValue(this_var); } - const double DestinationValue = inner_prod(Values, N); + const double destination_value = inner_prod(values, N); - ConstitutiveLawVector[iGaussPoint]->SetValue(ThisVar, DestinationValue, DestinationProcessInfo); + constitutive_law_vector[i_gauss_point]->SetValue(this_var, destination_value, destination_process_info); } } } diff --git a/applications/MeshingApplication/custom_processes/metric_fast_init_process.h b/applications/MeshingApplication/custom_processes/metric_fast_init_process.h index 3b686f1fc95f..00fa970e38f3 100755 --- a/applications/MeshingApplication/custom_processes/metric_fast_init_process.h +++ b/applications/MeshingApplication/custom_processes/metric_fast_init_process.h @@ -73,9 +73,8 @@ class MetricFastInit } /// Destructor. - virtual ~MetricFastInit() - { - } + ~MetricFastInit() override + = default; ///@} ///@name Access @@ -106,7 +105,7 @@ class MetricFastInit ///@name Operations ///@{ - virtual void Execute() override + void Execute() override { KRATOS_TRY; @@ -145,19 +144,19 @@ class MetricFastInit ///@{ /// Turn back information as a string. - virtual std::string Info() const override + std::string Info() const override { return "MetricFastInit"; } /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const override + void PrintInfo(std::ostream& rOStream) const override { rOStream << "MetricFastInit"; } /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const override + void PrintData(std::ostream& rOStream) const override { } @@ -213,6 +212,7 @@ class MetricFastInit ///@} ///@name Member Variables ///@{ + ModelPart& mrThisModelPart; ///@} diff --git a/applications/MeshingApplication/custom_processes/metrics_error_process.h b/applications/MeshingApplication/custom_processes/metrics_error_process.h new file mode 100644 index 000000000000..5ef3eddb2591 --- /dev/null +++ b/applications/MeshingApplication/custom_processes/metrics_error_process.h @@ -0,0 +1,357 @@ +// KRATOS __ __ _____ ____ _ _ ___ _ _ ____ +// | \/ | ____/ ___|| | | |_ _| \ | |/ ___| +// | |\/| | _| \___ \| |_| || || \| | | _ +// | | | | |___ ___) | _ || || |\ | |_| | +// |_| |_|_____|____/|_| |_|___|_| \_|\____| APPLICATION +// +// License: BSD License +// license: MeshingApplication/license.txt +// +// Main authors: Vicente Mataix Ferrándiz +// + +#if !defined(KRATOS_ERROR_METRICS_PROCESS) +#define KRATOS_ERROR_METRICS_PROCESS + +// Project includes +#include "utilities/math_utils.h" +#include "custom_utilities/metrics_math_utils.h" +#include "includes/kratos_parameters.h" +#include "includes/model_part.h" +#include "meshing_application.h" + +namespace Kratos +{ +///@name Kratos Globals +///@{ + +///@} +///@name Type Definitions +///@{ + + typedef ModelPart::NodesContainerType NodesArrayType; + typedef ModelPart::ElementsContainerType ElementsArrayType; + typedef ModelPart::ConditionsContainerType ConditionsArrayType; + typedef Node <3> NodeType; + +///@} +///@name Enum's +///@{ + +///@} +///@name Functions +///@{ + +///@} +///@name Kratos Classes +///@{ + +//// This class is can be used to compute the Metrics of the model part with an Hessian approach + +template +class ComputeErrorSolMetricProcess + : public Process +{ +public: + + ///@name Type Definitions + ///@{ + + /// Pointer definition of ComputeErrorSolMetricProcess + KRATOS_CLASS_POINTER_DEFINITION(ComputeErrorSolMetricProcess); + + ///@} + ///@name Life Cycle + ///@{ + + // Constructor + + /** + * This is the default constructor + * @param rThisModelPart: The model part to be computed + * @param ThisParameters: The input parameters + */ + + ComputeErrorSolMetricProcess( + ModelPart& rThisModelPart, + Parameters ThisParameters = Parameters(R"({})") + ) + :mThisModelPart(rThisModelPart) + { + Parameters DefaultParameters = Parameters(R"( + { + "minimal_size" : 0.1, + "maximal_size" : 10.0, + "enforce_current" : true, + "error_strategy_parameters": + { + } + })" ); + ThisParameters.ValidateAndAssignDefaults(DefaultParameters); + + mMinSize = ThisParameters["minimal_size"].GetDouble(); + mMaxSize = ThisParameters["maximal_size"].GetDouble(); + mEnforceCurrent = ThisParameters["enforce_current"].GetBool(); + } + + /// Destructor. + ~ComputeErrorSolMetricProcess() override = default; + + ///@} + ///@name Operators + ///@{ + + void operator()() + { + Execute(); + } + + ///@} + ///@name Operations + ///@{ + + /** + * We initialize the Metrics of the MMG sol using the Hessian Metric matrix approach + */ + + void Execute() override + { + // Iterate in the nodes + NodesArrayType& pNode = mThisModelPart.Nodes(); + int numNodes = pNode.end() - pNode.begin(); + + #pragma omp parallel for + for(int i = 0; i < numNodes; i++) + { + auto itNode = pNode.begin() + i; + + const double NodalH = itNode->FastGetSolutionStepValue(NODAL_H, 0); + + double ElementMinSize = mMinSize; + if ((ElementMinSize > NodalH) && (mEnforceCurrent == true)) + { + ElementMinSize = NodalH; + } + double ElementMaxSize = mMaxSize; + if ((ElementMaxSize > NodalH) && (mEnforceCurrent == true)) + { + ElementMaxSize = NodalH; + } + + // We compute the Metric + #ifdef KRATOS_DEBUG + if( itNode->Has(MMG_METRIC) == false) + { + KRATOS_ERROR << " MMG_METRIC not defined for node " << itNode->Id(); + } + #endif + Vector& Metric = itNode->GetValue(MMG_METRIC); + + #ifdef KRATOS_DEBUG + if(Metric.size() != TDim * 3 - 3) + { + KRATOS_ERROR << "Wrong size of vector MMG_METRIC found for node " << itNode->Id() << " size is " << Metric.size() << " expected size was " << TDim * 3 - 3; + } + #endif + + const double NodalError = itNode->GetValue(NODAL_ERROR); + const double NormMetric = norm_2(Metric); + if (NormMetric > 0.0) // NOTE: This means we combine differents metrics, at the same time means that the metric should be reseted each time + { + const Vector OldMetric = itNode->GetValue(MMG_METRIC); + const Vector NewMetric = ComputeErrorMetricTensor(NodalH, NodalError, ElementMinSize, ElementMaxSize); + + Metric = MetricsMathUtils::IntersectMetrics(OldMetric, NewMetric); + } + else + { + Metric = ComputeErrorMetricTensor(NodalH, NodalError, ElementMinSize, ElementMaxSize); + } + } + } + + ///@} + ///@name Access + ///@{ + + + ///@} + ///@name Inquiry + ///@{ + + + ///@} + ///@name Input and output + ///@{ + + /// Turn back information as a string. + std::string Info() const override + { + return "ComputeErrorSolMetricProcess"; + } + + /// Print information about this object. + void PrintInfo(std::ostream& rOStream) const override + { + rOStream << "ComputeErrorSolMetricProcess"; + } + + /// Print object"s data. + void PrintData(std::ostream& rOStream) const override + { + } + +protected: + ///@name Protected static Member Variables + ///@{ + + + ///@} + ///@name Protected member Variables + ///@{ + + + ///@} + ///@name Protected Operators + ///@{ + + + ///@} + ///@name Protected Operations + ///@{ + + + ///@} + ///@name Protected Access + ///@{ + + + ///@} + ///@name Protected Inquiry + ///@{ + + + ///@} + ///@name Protected LifeCycle + ///@{ + + + ///@} + +private: + ///@name Private static Member Variables + ///@{ + + ///@} + ///@name Private member Variables + ///@{ + + ModelPart& mThisModelPart; // The model part to compute + double mMinSize; // The minimal size of the elements + double mMaxSize; // The maximal size of the elements + bool mEnforceCurrent; // With this we choose if we inforce the current nodal size (NODAL_H) + double mTolerance; // The error tolerance considered + + ///@} + ///@name Private Operators + ///@{ + + ///@} + ///@name Private Operations + ///@{ + + /** + * This function computes the metric tensor using as reference the nodal error + * @param OldNodalH: The old size of the mesh in that node + * @param NodalError: The weighted on the node + * @param ElementMinSize: This way we can impose as minimum as the previous size if we desire + * @param ElementMaxSize: This way we can impose as maximum as the previous size if we desire + */ + + Vector ComputeErrorMetricTensor( + const double& OldNodalH, + const double& NodalError, + const double& ElementMinSize, + const double& ElementMaxSize + ) + { + // Calculating Metric parameters + const double MinRatio = 1.0/(ElementMinSize * ElementMinSize); +// const double MinRatio = 1.0/(mMinSize * mMinSize); + const double MaxRatio = 1.0/(ElementMaxSize * ElementMaxSize); +// const double MaxRatio = 1.0/(mMaxSize * mMaxSize); + + const double AverageNodalError = mThisModelPart.GetProcessInfo()[AVERAGE_NODAL_ERROR]; + + boost::numeric::ublas::bounded_matrix MetricMatrix = ZeroMatrix(TDim, TDim); + + const double NewNodalH = OldNodalH * AverageNodalError/NodalError; + + const double NewNodalRatio = NewNodalH > ElementMinSize ? MinRatio : NewNodalH < ElementMaxSize ? MaxRatio : 1.0/(NewNodalH * NewNodalH); + + // Right now just considering isotropic mesh + for (unsigned int iDim = 0; iDim < TDim; iDim++) + { + MetricMatrix(iDim, iDim) = NewNodalRatio; + } + + // Finally we transform to a vector + const Vector Metric = MetricsMathUtils::TensorToVector(MetricMatrix); + + return Metric; + } + + ///@} + ///@name Private Access + ///@{ + + ///@} + ///@name Private Inquiry + ///@{ + + ///@} + ///@name Private LifeCycle + ///@{ + + ///@} + ///@name Un accessible methods + ///@{ + + /// Assignment operator. + ComputeErrorSolMetricProcess& operator=(ComputeErrorSolMetricProcess const& rOther); + + /// Copy constructor. + //ComputeErrorSolMetricProcess(ComputeErrorSolMetricProcess const& rOther); + + ///@} +};// class ComputeErrorSolMetricProcess +///@} + + +///@name Type Definitions +///@{ + + +///@} +///@name Input and output +///@{ + +/// input stream function +template +inline std::istream& operator >> (std::istream& rIStream, + ComputeErrorSolMetricProcess& rThis); + +/// output stream function +template +inline std::ostream& operator << (std::ostream& rOStream, + const ComputeErrorSolMetricProcess& rThis) +{ + rThis.PrintInfo(rOStream); + rOStream << std::endl; + rThis.PrintData(rOStream); + + return rOStream; +} + +};// namespace Kratos. +#endif /* KRATOS_ERROR_METRICS_PROCESS defined */ diff --git a/applications/MeshingApplication/custom_processes/metrics_hessian_process.h b/applications/MeshingApplication/custom_processes/metrics_hessian_process.h index 40ac986b3036..06feba2a1caa 100644 --- a/applications/MeshingApplication/custom_processes/metrics_hessian_process.h +++ b/applications/MeshingApplication/custom_processes/metrics_hessian_process.h @@ -76,14 +76,7 @@ class ComputeHessianSolMetricProcess /** * This is the default constructor * @param rThisModelPart: The model part to be computed - * @param rMinSize: The min size of element - * @param rMaxSize: The maximal size of the elements - * @param rInterpError: The interpolation error assumed - * @param rMeshConstant: The constant that appears in papers an none knows where comes from, where... - * @param rAnisRatio: The anisotropic ratio - * @param rBoundLayer: The boundary layer limit - * @param rInterpolation: The interpolation type - * @param rVariable: The variable considered for remeshing + * @param ThisParameters: The input parameters */ ComputeHessianSolMetricProcess( @@ -138,7 +131,7 @@ class ComputeHessianSolMetricProcess } /// Destructor. - virtual ~ComputeHessianSolMetricProcess() {} + ~ComputeHessianSolMetricProcess() override = default; ///@} ///@name Operators @@ -157,45 +150,44 @@ class ComputeHessianSolMetricProcess * We initialize the metrics of the MMG sol using the Hessian metric matrix approach */ - virtual void Execute() + void Execute() override { // Iterate in the nodes - NodesArrayType& pNode = mThisModelPart.Nodes(); - int numNodes = pNode.end() - pNode.begin(); + NodesArrayType& NodesArray = mThisModelPart.Nodes(); + int numNodes = NodesArray.end() - NodesArray.begin(); CalculateAuxiliarHessian(); #pragma omp parallel for for(int i = 0; i < numNodes; i++) { - auto itNode = pNode.begin() + i; + auto itNode = NodesArray.begin() + i; if ( itNode->SolutionStepsDataHas( mVariable ) == false ) { KRATOS_ERROR << "Missing variable on node " << itNode->Id() << std::endl; } - const double distance = itNode->FastGetSolutionStepValue(DISTANCE, 0); // TODO: This should be changed for the varaible of interestin the future. This means that the value of the boundary value would be changed to a threshold value instead - const Vector& hessian = itNode->GetValue(AUXILIAR_HESSIAN); + const double Distance = itNode->FastGetSolutionStepValue(DISTANCE); // TODO: This should be changed for the varaible of interestin the future. This means that the value of the boundary value would be changed to a threshold value instead + const Vector& Hessian = itNode->GetValue(AUXILIAR_HESSIAN); - const double nodal_h = itNode->FastGetSolutionStepValue(NODAL_H, 0); + const double NodalH = itNode->FastGetSolutionStepValue(NODAL_H); - double element_min_size = mMinSize; - if ((element_min_size > nodal_h) && (mEnforceCurrent == true)) + double ElementMinSize = mMinSize; + if ((ElementMinSize > NodalH) && (mEnforceCurrent == true)) { - element_min_size = nodal_h; + ElementMinSize = NodalH; } - double element_max_size = mMaxSize; - if ((element_max_size > nodal_h) && (mEnforceCurrent == true)) + double ElementMaxSize = mMaxSize; + if ((ElementMaxSize > NodalH) && (mEnforceCurrent == true)) { - element_max_size = nodal_h; + ElementMaxSize = NodalH; } - const double ratio = CalculateAnisotropicRatio(distance, mAnisRatio, mBoundLayer, mInterpolation); + const double Ratio = CalculateAnisotropicRatio(Distance, mAnisRatio, mBoundLayer, mInterpolation); // For postprocess pourposes - double& anisotropic_ratio = itNode->FastGetSolutionStepValue(ANISOTROPIC_RATIO, 0); - anisotropic_ratio = ratio; + itNode->SetValue(ANISOTROPIC_RATIO, Ratio); // We compute the metric #ifdef KRATOS_DEBUG @@ -204,26 +196,26 @@ class ComputeHessianSolMetricProcess KRATOS_ERROR << " MMG_METRIC not defined for node " << itNode->Id(); } #endif - Vector& metric = itNode->GetValue(MMG_METRIC); + Vector& Metric = itNode->GetValue(MMG_METRIC); #ifdef KRATOS_DEBUG - if(metric.size() != TDim * 3 - 3) + if(Metric.size() != TDim * 3 - 3) { - KRATOS_ERROR << "Wrong size of vector MMG_METRIC found for node " << itNode->Id() << " size is " << metric.size() << " expected size was " << TDim * 3 - 3; + KRATOS_ERROR << "Wrong size of vector MMG_METRIC found for node " << itNode->Id() << " size is " << Metric.size() << " expected size was " << TDim * 3 - 3; } #endif - const double normmetric = norm_2(metric); - if (normmetric > 0.0) // NOTE: This means we combine differents metrics, at the same time means that the metric should be reseted each time + const double NormMetric = norm_2(Metric); + if (NormMetric > 0.0) // NOTE: This means we combine differents metrics, at the same time means that the metric should be reseted each time { - const Vector old_metric = itNode->GetValue(MMG_METRIC); - const Vector new_metric = ComputeHessianMetricTensor(hessian, ratio, element_min_size, element_max_size); + const Vector OldMetric = itNode->GetValue(MMG_METRIC); + const Vector NewMetric = ComputeHessianMetricTensor(Hessian, Ratio, ElementMinSize, ElementMaxSize); - metric = MetricsMathUtils::IntersectMetrics(old_metric, new_metric); + Metric = MetricsMathUtils::IntersectMetrics(OldMetric, NewMetric); } else { - metric = ComputeHessianMetricTensor(hessian, ratio, element_min_size, element_max_size); + Metric = ComputeHessianMetricTensor(Hessian, Ratio, ElementMinSize, ElementMaxSize); } } } @@ -243,19 +235,19 @@ class ComputeHessianSolMetricProcess ///@{ /// Turn back information as a string. - virtual std::string Info() const + std::string Info() const override { return "ComputeHessianSolMetricProcess"; } /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const + void PrintInfo(std::ostream& rOStream) const override { rOStream << "ComputeHessianSolMetricProcess"; } /// Print object"s data. - virtual void PrintData(std::ostream& rOStream) const + void PrintData(std::ostream& rOStream) const override { } @@ -324,86 +316,88 @@ class ComputeHessianSolMetricProcess ///@{ /** - * This function is used to compute the Hessian metric tensor, note that when using the Hessian, more than one metric can be defined simultaneously, so in consecuence we need to define the elipsoid which defines the volume of maximal intersection - * @param hessian: The hessian tensor condensed already computed - * @param ratio: The anisotropic ratio + * This function is used to compute the Hessian Metric tensor, note that when using the Hessian, more than one Metric can be defined simultaneously, so in consecuence we need to define the elipsoid which defines the volume of maximal intersection + * @param Hessian: The hessian tensor condensed already computed + * @param AnisotropicRatio: The anisotropic ratio + * @param ElementMinSize: The min size of element + * @param ElementMaxSize: The maximal size of the elements */ Vector ComputeHessianMetricTensor( - const Vector& hessian, - const double& ratio, - const double& element_min_size, // This way we can impose as minimum as the previous size if we desire - const double& element_max_size // This way we can impose as maximum as the previous size if we desire + const Vector& Hessian, + const double& AnisotropicRatio, + const double& ElementMinSize, // This way we can impose as minimum as the previous size if we desire + const double& ElementMaxSize // This way we can impose as maximum as the previous size if we desire ) { - // Calculating metric parameters - const double c_epsilon = mMeshConstant/mInterpError; - const double min_ratio = 1.0/(element_min_size * element_min_size); -// const double min_ratio = 1.0/(mMinSize * mMinSize); - const double max_ratio = 1.0/(element_max_size * element_max_size); -// const double max_ratio = 1.0/(mMaxSize * mMaxSize); + // Calculating Metric parameters + const double CEpsilon = mMeshConstant/mInterpError; + const double MinRatio = 1.0/(ElementMinSize * ElementMinSize); +// const double MinRatio = 1.0/(mMinSize * mMinSize); + const double MaxRatio = 1.0/(ElementMaxSize * ElementMaxSize); +// const double MaxRatio = 1.0/(mMaxSize * mMaxSize); - typedef boost::numeric::ublas::bounded_matrix temp_type; + typedef bounded_matrix TempType; // Declaring the eigen system - boost::numeric::ublas::bounded_matrix eigen_vector_matrix; - boost::numeric::ublas::bounded_matrix eigen_values_matrix; + bounded_matrix EigenVectorMatrix; + bounded_matrix EigenValuesMatrix; // We first transform into a matrix - const boost::numeric::ublas::bounded_matrix hessian_matrix = MetricsMathUtils::VectorToTensor(hessian); + const bounded_matrix HessianMatrix = MetricsMathUtils::VectorToTensor(Hessian); - MathUtils::EigenSystem(hessian_matrix, eigen_vector_matrix, eigen_values_matrix, 1e-18, 20); + MathUtils::EigenSystem(HessianMatrix, EigenVectorMatrix, EigenValuesMatrix, 1e-18, 20); - // Recalculate the metric eigen values + // Recalculate the Metric eigen values for (unsigned int i = 0; i < TDim; i++) { - eigen_values_matrix(i, i) = MathUtils::Min(MathUtils::Max(c_epsilon * std::abs(eigen_values_matrix(i, i)), max_ratio), min_ratio); + EigenValuesMatrix(i, i) = MathUtils::Min(MathUtils::Max(CEpsilon * std::abs(EigenValuesMatrix(i, i)), MaxRatio), MinRatio); } // Considering anisotropic - if (ratio < 1.0) + if (AnisotropicRatio < 1.0) { - double eigen_max = eigen_values_matrix(0, 0); - double eigen_min = eigen_values_matrix(1, 1); + double EigenMax = EigenValuesMatrix(0, 0); + double EigenMin = EigenValuesMatrix(1, 1); for (unsigned int i = 1; i < TDim - 1; i++) { - eigen_max = MathUtils::Max(eigen_max, eigen_values_matrix(i, i)); - eigen_min = MathUtils::Min(eigen_max, eigen_values_matrix(i, i)); + EigenMax = MathUtils::Max(EigenMax, EigenValuesMatrix(i, i)); + EigenMin = MathUtils::Min(EigenMax, EigenValuesMatrix(i, i)); } - const double eigen_radius = std::abs(eigen_max - eigen_min) * (1.0 - ratio); - const double rel_eigen_radius = std::abs(eigen_max - eigen_radius); + const double EigenRadius = std::abs(EigenMax - EigenMin) * (1.0 - AnisotropicRatio); + const double RelativeEigenRadius = std::abs(EigenMax - EigenRadius); for (unsigned int i = 0; i < TDim; i++) { - eigen_values_matrix(i, i) = MathUtils::Max(MathUtils::Min(eigen_values_matrix(i, i), eigen_max), rel_eigen_radius); + EigenValuesMatrix(i, i) = MathUtils::Max(MathUtils::Min(EigenValuesMatrix(i, i), EigenMax), RelativeEigenRadius); } } else // NOTE: For isotropic we should consider the maximum of the eigenvalues { - double eigen_max = eigen_values_matrix(0, 0); + double EigenMax = EigenValuesMatrix(0, 0); for (unsigned int i = 1; i < TDim - 1; i++) { - eigen_max = MathUtils::Max(eigen_max, eigen_values_matrix(i, i)); + EigenMax = MathUtils::Max(EigenMax, EigenValuesMatrix(i, i)); } for (unsigned int i = 0; i < TDim; i++) { - eigen_values_matrix(i, i) = eigen_max; + EigenValuesMatrix(i, i) = EigenMax; } - eigen_vector_matrix = IdentityMatrix(TDim, TDim); + EigenVectorMatrix = IdentityMatrix(TDim, TDim); } // We compute the product - const boost::numeric::ublas::bounded_matrix metric_matrix = prod(trans(eigen_vector_matrix), prod(eigen_values_matrix, eigen_vector_matrix)); + const bounded_matrix MetricMatrix = prod(trans(EigenVectorMatrix), prod(EigenValuesMatrix, EigenVectorMatrix)); // Finally we transform to a vector - const Vector metric = MetricsMathUtils::TensorToVector(metric_matrix); + const Vector Metric = MetricsMathUtils::TensorToVector(MetricMatrix); - return metric; + return Metric; } /** - * This calculates the auxiliar hessian needed for the metric + * This calculates the auxiliar hessian needed for the Metric * @param rThisModelPart: The original model part where we compute the hessian * @param rVariable: The variable to calculate the hessian */ @@ -411,90 +405,92 @@ class ComputeHessianSolMetricProcess void CalculateAuxiliarHessian() { // Iterate in the nodes - NodesArrayType& pNode = mThisModelPart.Nodes(); - auto numNodes = pNode.end() - pNode.begin(); + NodesArrayType& NodesArray = mThisModelPart.Nodes(); + int numNodes = NodesArray.end() - NodesArray.begin(); -// #pragma omp parallel for // NOTE: Be careful with the parallel (MUST BE INITIALIZED TO BE THREAD SAFE) - for(unsigned int i = 0; i < numNodes; i++) + // Declaring auxiliar vector + const Vector AuxZeroVector = ZeroVector(3 * (TDim - 1)); + + #pragma omp parallel for + for(int i = 0; i < numNodes; i++) { - auto itNode = pNode.begin() + i; + auto itNode = NodesArray.begin() + i; - Vector& hessian = itNode->GetValue(AUXILIAR_HESSIAN); - hessian = ZeroVector(3 * (TDim - 1)); + itNode->SetValue(AUXILIAR_HESSIAN, AuxZeroVector); } // Compute auxiliar gradient - ComputeNodalGradientProcess GradientProcess = ComputeNodalGradientProcess(mThisModelPart, mVariable, AUXILIAR_GRADIENT, NODAL_AREA); + ComputeNodalGradientProcess GradientProcess = ComputeNodalGradientProcess(mThisModelPart, mVariable, AUXILIAR_GRADIENT, NODAL_AREA); GradientProcess.Execute(); // Iterate in the conditions - ElementsArrayType& pElement = mThisModelPart.Elements(); - int numElements = pElement.end() - pElement.begin(); + ElementsArrayType& ElementsArray = mThisModelPart.Elements(); + int numElements = ElementsArray.end() - ElementsArray.begin(); #pragma omp parallel for for(int i = 0; i < numElements; i++) { - auto itElem = pElement.begin() + i; + auto itElem = ElementsArray.begin() + i; Element::GeometryType& geom = itElem->GetGeometry(); double Volume; if (geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Triangle2D3) { - boost::numeric::ublas::bounded_matrix DN_DX; + bounded_matrix DN_DX; array_1d N; GeometryUtils::CalculateGeometryData(geom, DN_DX, N, Volume); - boost::numeric::ublas::bounded_matrix values; - for(unsigned int i_node = 0; i_node < 3; i_node++) + bounded_matrix values; + for(unsigned int iNode = 0; iNode < 3; iNode++) { - const array_1d aux_grad = geom[i_node].FastGetSolutionStepValue(AUXILIAR_GRADIENT); - values(i_node, 0) = aux_grad[0]; - values(i_node, 1) = aux_grad[1]; + const array_1d AuxGrad = geom[iNode].GetValue(AUXILIAR_GRADIENT); + values(iNode, 0) = AuxGrad[0]; + values(iNode, 1) = AuxGrad[1]; } - const boost::numeric::ublas::bounded_matrix Hessian = prod(trans(DN_DX), values); + const bounded_matrix Hessian = prod(trans(DN_DX), values); const Vector HessianCond = MetricsMathUtils<2>::TensorToVector(Hessian); - for(unsigned int i_node = 0; i_node < geom.size(); i_node++) + for(unsigned int iNode = 0; iNode < geom.size(); iNode++) { for(unsigned int k = 0; k < 3; k++) { - double& val = geom[i_node].GetValue(AUXILIAR_HESSIAN)[k]; + double& val = geom[iNode].GetValue(AUXILIAR_HESSIAN)[k]; #pragma omp atomic - val += N[i_node] * Volume * HessianCond[k]; + val += N[iNode] * Volume * HessianCond[k]; } } } else if (geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Tetrahedra3D4) { - boost::numeric::ublas::bounded_matrix DN_DX; + bounded_matrix DN_DX; array_1d N; GeometryUtils::CalculateGeometryData(geom, DN_DX, N, Volume); - boost::numeric::ublas::bounded_matrix values; - for(unsigned int i_node = 0; i_node < 4; i_node++) + bounded_matrix values; + for(unsigned int iNode = 0; iNode < 4; iNode++) { - const array_1d aux_grad = geom[i_node].FastGetSolutionStepValue(AUXILIAR_GRADIENT); - values(i_node, 0) = aux_grad[0]; - values(i_node, 1) = aux_grad[1]; - values(i_node, 2) = aux_grad[2]; + const array_1d AuxGrad = geom[iNode].GetValue(AUXILIAR_GRADIENT); + values(iNode, 0) = AuxGrad[0]; + values(iNode, 1) = AuxGrad[1]; + values(iNode, 2) = AuxGrad[2]; } - const boost::numeric::ublas::bounded_matrix Hessian = prod(trans(DN_DX), values); + const bounded_matrix Hessian = prod(trans(DN_DX), values); const Vector HessianCond = MetricsMathUtils<3>::TensorToVector(Hessian); - for(unsigned int i_node = 0; i_node < geom.size(); i_node++) + for(unsigned int iNode = 0; iNode < geom.size(); iNode++) { for(unsigned int k = 0; k < 6; k++) { - double& val = geom[i_node].GetValue(AUXILIAR_HESSIAN)[k]; + double& val = geom[iNode].GetValue(AUXILIAR_HESSIAN)[k]; #pragma omp atomic - val += N[i_node] * Volume * HessianCond[k]; + val += N[iNode] * Volume * HessianCond[k]; } } } @@ -507,7 +503,7 @@ class ComputeHessianSolMetricProcess #pragma omp parallel for for(int i = 0; i < numNodes; i++) { - auto itNode = pNode.begin() + i; + auto itNode = NodesArray.begin() + i; itNode->GetValue(AUXILIAR_HESSIAN) /= itNode->FastGetSolutionStepValue(NODAL_AREA); } } diff --git a/applications/MeshingApplication/custom_processes/metrics_levelset_process.h b/applications/MeshingApplication/custom_processes/metrics_levelset_process.h index ff2da93feb1a..9d88537ff92d 100644 --- a/applications/MeshingApplication/custom_processes/metrics_levelset_process.h +++ b/applications/MeshingApplication/custom_processes/metrics_levelset_process.h @@ -75,11 +75,7 @@ class ComputeLevelSetSolMetricProcess /** * This is the default constructor * @param rThisModelPart: The model part to be computed - * @param rVariableGradient: The gradient variable to compute - * @param rMinSize: The min size of element - * @param rAnisRatio: The anisotropic ratio - * @param rBoundLayer: The boundary layer limit - * @param rInterpolation: The interpolation type + * @param ThisParameters: The input parameters */ ComputeLevelSetSolMetricProcess( @@ -88,9 +84,7 @@ class ComputeLevelSetSolMetricProcess Parameters ThisParameters = Parameters(R"({})") ) :mThisModelPart(rThisModelPart), - mVariableGradient(rVariableGradient), - mMinSize(ThisParameters["minimal_size"].GetDouble()), - mEnforceCurrent(ThisParameters["enforce_current"].GetBool()) + mVariableGradient(rVariableGradient) { Parameters DefaultParameters = Parameters(R"( { @@ -106,6 +100,9 @@ class ComputeLevelSetSolMetricProcess })" ); ThisParameters.ValidateAndAssignDefaults(DefaultParameters); + mMinSize = ThisParameters["minimal_size"].GetDouble(); + mEnforceCurrent = ThisParameters["enforce_current"].GetBool(); + // In case we have isotropic remeshing (default values) if (ThisParameters["anisotropy_remeshing"].GetBool() == false) { @@ -122,7 +119,7 @@ class ComputeLevelSetSolMetricProcess } /// Destructor. - virtual ~ComputeLevelSetSolMetricProcess() {} + ~ComputeLevelSetSolMetricProcess() override = default; ///@} ///@name Operators @@ -141,7 +138,7 @@ class ComputeLevelSetSolMetricProcess * We initialize the metrics of the MMG sol using a level set approach */ - virtual void Execute() + void Execute() override { // Iterate in the nodes NodesArrayType& pNode = mThisModelPart.Nodes(); @@ -157,28 +154,26 @@ class ComputeLevelSetSolMetricProcess KRATOS_ERROR << "Missing gradient variable on node " << itNode->Id() << std::endl; } - const double distance = itNode->FastGetSolutionStepValue(DISTANCE, 0); - array_1d gradient_value = itNode->FastGetSolutionStepValue(mVariableGradient, 0); + const double Distance = itNode->FastGetSolutionStepValue(DISTANCE, 0); + array_1d GradientValue = itNode->FastGetSolutionStepValue(mVariableGradient, 0); - const double ratio = CalculateAnisotropicRatio(distance, mAnisRatio, mBoundLayer, mInterpolation); + const double Ratio = CalculateAnisotropicRatio(Distance, mAnisRatio, mBoundLayer, mInterpolation); // For postprocess pourposes - double& anisotropic_ratio = itNode->FastGetSolutionStepValue(ANISOTROPIC_RATIO, 0); - anisotropic_ratio = ratio; + itNode->SetValue(ANISOTROPIC_RATIO, Ratio); - - double element_size = mMinSize; - const double nodal_h = itNode->FastGetSolutionStepValue(NODAL_H, 0); - if (((element_size > nodal_h) && (mEnforceCurrent == true)) || (std::abs(distance) > mBoundLayer)) + double ElementSize = mMinSize; + const double NodalH = itNode->FastGetSolutionStepValue(NODAL_H, 0); + if (((ElementSize > NodalH) && (mEnforceCurrent == true)) || (std::abs(Distance) > mBoundLayer)) { - element_size = nodal_h; + ElementSize = NodalH; } - const double tolerance = 1.0e-12; - const double norm = norm_2(gradient_value); - if (norm > tolerance) + const double Tolerance = 1.0e-12; + const double NormGradientValue = norm_2(GradientValue); + if (NormGradientValue > Tolerance) { - gradient_value /= norm; + GradientValue /= NormGradientValue; } // We compute the metric @@ -188,26 +183,26 @@ class ComputeLevelSetSolMetricProcess KRATOS_ERROR << " MMG_METRIC not defined for node " << itNode->Id(); } #endif - Vector& metric = itNode->GetValue(MMG_METRIC); + Vector& Metric = itNode->GetValue(MMG_METRIC); #ifdef KRATOS_DEBUG - if(metric.size() != TDim * 3 - 3) + if(Metric.size() != TDim * 3 - 3) { - KRATOS_ERROR << "Wrong size of vector MMG_METRIC found for node " << itNode->Id() << " size is " << metric.size() << " expected size was " << TDim * 3 - 3; + KRATOS_ERROR << "Wrong size of vector MMG_METRIC found for node " << itNode->Id() << " size is " << Metric.size() << " expected size was " << TDim * 3 - 3; } #endif - const double normmetric = norm_2(metric); - if (normmetric > 0.0) // NOTE: This means we combine differents metrics, at the same time means that the metric should be reseted each time + const double NormMetric = norm_2(Metric); + if (NormMetric > 0.0) // NOTE: This means we combine differents metrics, at the same time means that the metric should be reseted each time { - const Vector old_metric = itNode->GetValue(MMG_METRIC); - const Vector new_metric = ComputeLevelSetMetricTensor(gradient_value, ratio, element_size); + const Vector OldMetric = itNode->GetValue(MMG_METRIC); + const Vector NewMetric = ComputeLevelSetMetricTensor(GradientValue, Ratio, ElementSize); - metric = MetricsMathUtils::IntersectMetrics(old_metric, new_metric); + Metric = MetricsMathUtils::IntersectMetrics(OldMetric, NewMetric); } else { - metric = ComputeLevelSetMetricTensor(gradient_value, ratio, element_size); + Metric = ComputeLevelSetMetricTensor(GradientValue, Ratio, ElementSize); } } } @@ -227,19 +222,19 @@ class ComputeLevelSetSolMetricProcess ///@{ /// Turn back information as a string. - virtual std::string Info() const + std::string Info() const override { return "ComputeLevelSetSolMetricProcess"; } /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const + void PrintInfo(std::ostream& rOStream) const override { rOStream << "ComputeLevelSetSolMetricProcess"; } /// Print object"s data. - virtual void PrintData(std::ostream& rOStream) const + void PrintData(std::ostream& rOStream) const override { } @@ -293,7 +288,7 @@ class ComputeLevelSetSolMetricProcess double mMinSize; // The minimal size of the elements bool mEnforceCurrent; // With this we choose if we inforce the current nodal size (NODAL_H) double mAnisRatio; // The minimal anisotropic ratio (0 < ratio < 1) - double mBoundLayer; // The boundary layer limit distance + double mBoundLayer; // The boundary layer limit Distance Interpolation mInterpolation; // The interpolation type ///@} @@ -306,16 +301,16 @@ class ComputeLevelSetSolMetricProcess /** * It calculates the tensor of the scalar, necessary to get the solution before remeshing - * @param gradient_value: The gradient of the scalar to remesh - * @param ratio: The alpha parameter used to remesh - * @param element_size: The minimum size of the elements + * @param GradientValue: The gradient of the scalar to remesh + * @param Ratio: The alpha parameter used to remesh + * @param ElementSize: The minimum size of the elements * @param node_id: The id of the node */ Vector ComputeLevelSetMetricTensor( - const array_1d& gradient_value, - const double& ratio, - const double& element_size + const array_1d& GradientValue, + const double& Ratio, + const double& ElementSize ); @@ -347,42 +342,42 @@ class ComputeLevelSetSolMetricProcess /** * This calculates the anisotropic ratio - * @param distance: Distance parameter + * @param Distance: Distance parameter */ double CalculateAnisotropicRatio( - const double& distance, + const double& Distance, const double& rAnisRatio, const double& rBoundLayer, const Interpolation& rInterpolation ) { - const double tolerance = 1.0e-12; - double ratio = 1.0; // NOTE: Isotropic mesh + const double Tolerance = 1.0e-12; + double Ratio = 1.0; // NOTE: Isotropic mesh if (rAnisRatio < 1.0) { - if (std::abs(distance) <= rBoundLayer) + if (std::abs(Distance) <= rBoundLayer) { if (rInterpolation == Constant) { - ratio = rAnisRatio; + Ratio = rAnisRatio; } else if (rInterpolation == Linear) { - ratio = rAnisRatio + (std::abs(distance)/rBoundLayer) * (1.0 - rAnisRatio); + Ratio = rAnisRatio + (std::abs(Distance)/rBoundLayer) * (1.0 - rAnisRatio); } else if (rInterpolation == Exponential) { - ratio = - std::log(std::abs(distance)/rBoundLayer) * rAnisRatio + tolerance; - if (ratio > 1.0) + Ratio = - std::log(std::abs(Distance)/rBoundLayer) * rAnisRatio + Tolerance; + if (Ratio > 1.0) { - ratio = 1.0; + Ratio = 1.0; } } } } - return ratio; + return Ratio; } ///@} @@ -416,26 +411,26 @@ class ComputeLevelSetSolMetricProcess template<> Vector ComputeLevelSetSolMetricProcess<2>::ComputeLevelSetMetricTensor( - const array_1d& gradient_value, - const double& ratio, - const double& element_size + const array_1d& GradientValue, + const double& Ratio, + const double& ElementSize ) { - Vector metric; - metric.resize(3, false); + Vector Metric; + Metric.resize(3, false); - const double coeff0 = 1.0/(element_size * element_size); - const double coeff1 = coeff0/(ratio * ratio); + const double Coeff0 = 1.0/(ElementSize * ElementSize); + const double Coeff1 = Coeff0/(Ratio * Ratio); - const double v0v0 = gradient_value[0]*gradient_value[0]; - const double v0v1 = gradient_value[0]*gradient_value[1]; - const double v1v1 = gradient_value[1]*gradient_value[1]; + const double v0v0 = GradientValue[0]*GradientValue[0]; + const double v0v1 = GradientValue[0]*GradientValue[1]; + const double v1v1 = GradientValue[1]*GradientValue[1]; - metric[0] = coeff0*(1.0 - v0v0) + coeff1*v0v0; - metric[1] = coeff0*( - v0v1) + coeff1*v0v1; - metric[2] = coeff0*(1.0 - v1v1) + coeff1*v1v1; + Metric[0] = Coeff0*(1.0 - v0v0) + Coeff1*v0v0; + Metric[1] = Coeff0*( - v0v1) + Coeff1*v0v1; + Metric[2] = Coeff0*(1.0 - v1v1) + Coeff1*v1v1; - return metric; + return Metric; } /***********************************************************************************/ @@ -443,32 +438,32 @@ class ComputeLevelSetSolMetricProcess template<> Vector ComputeLevelSetSolMetricProcess<3>::ComputeLevelSetMetricTensor( - const array_1d& gradient_value, - const double& ratio, - const double& element_size + const array_1d& GradientValue, + const double& Ratio, + const double& ElementSize ) { - Vector metric; - metric.resize(6, false); + Vector Metric; + Metric.resize(6, false); - const double coeff0 = 1.0/(element_size * element_size); - const double coeff1 = coeff0/(ratio * ratio); + const double Coeff0 = 1.0/(ElementSize * ElementSize); + const double Coeff1 = Coeff0/(Ratio * Ratio); - const double v0v0 = gradient_value[0]*gradient_value[0]; - const double v0v1 = gradient_value[0]*gradient_value[1]; - const double v0v2 = gradient_value[0]*gradient_value[2]; - const double v1v1 = gradient_value[1]*gradient_value[1]; - const double v1v2 = gradient_value[1]*gradient_value[2]; - const double v2v2 = gradient_value[2]*gradient_value[2]; + const double v0v0 = GradientValue[0]*GradientValue[0]; + const double v0v1 = GradientValue[0]*GradientValue[1]; + const double v0v2 = GradientValue[0]*GradientValue[2]; + const double v1v1 = GradientValue[1]*GradientValue[1]; + const double v1v2 = GradientValue[1]*GradientValue[2]; + const double v2v2 = GradientValue[2]*GradientValue[2]; - metric[0] = coeff0*(1.0 - v0v0) + coeff1*v0v0; - metric[1] = coeff0*( - v0v1) + coeff1*v0v1; - metric[2] = coeff0*( - v0v2) + coeff1*v0v2; - metric[3] = coeff0*(1.0 - v1v1) + coeff1*v1v1; - metric[4] = coeff0*( - v1v2) + coeff1*v1v2; - metric[5] = coeff0*(1.0 - v2v2) + coeff1*v2v2; - - return metric; + Metric[0] = Coeff0*(1.0 - v0v0) + Coeff1*v0v0; + Metric[1] = Coeff0*( - v0v1) + Coeff1*v0v1; + Metric[2] = Coeff0*( - v0v2) + Coeff1*v0v2; + Metric[3] = Coeff0*(1.0 - v1v1) + Coeff1*v1v1; + Metric[4] = Coeff0*( - v1v2) + Coeff1*v1v2; + Metric[5] = Coeff0*(1.0 - v2v2) + Coeff1*v2v2; + + return Metric; } ///@name Type Definitions diff --git a/applications/MeshingApplication/custom_processes/mmg_process.cpp b/applications/MeshingApplication/custom_processes/mmg_process.cpp new file mode 100644 index 000000000000..91173e5064e1 --- /dev/null +++ b/applications/MeshingApplication/custom_processes/mmg_process.cpp @@ -0,0 +1,2429 @@ +// KRATOS __ __ _____ ____ _ _ ___ _ _ ____ +// | \/ | ____/ ___|| | | |_ _| \ | |/ ___| +// | |\/| | _| \___ \| |_| || || \| | | _ +// | | | | |___ ___) | _ || || |\ | |_| | +// |_| |_|_____|____/|_| |_|___|_| \_|\____| APPLICATION +// +// License: BSD License +// license: MeshingApplication/license.txt +// +// Main authors: Vicente Mataix Ferrándiz +// + +// System includes +#include + +// External includes +// The includes related with the MMG library +#include "mmg/libmmg.h" +#include "mmg/mmg2d/libmmg2d.h" +#include "mmg/mmg3d/libmmg3d.h" +// #include "mmg/mmgs/libmmgs.h" + +// Project includes +#include "custom_processes/mmg_process.h" +// We indlude the internal variable interpolation process +#include "custom_processes/nodal_values_interpolation_process.h" +#include "custom_processes/internal_variables_interpolation_process.h" +// Include the point locator +#include "utilities/binbased_fast_point_locator.h" +// Include the spatial containers needed for search +#include "spatial_containers/spatial_containers.h" // kd-tree + +// NOTE: The following contains the license of the MMG library +/* ============================================================================= +** Copyright (c) Bx INP/Inria/UBordeaux/UPMC, 2004- . +** +** mmg is free software: you can redistribute it and/or modify it +** under the terms of the GNU Lesser General Public License as published +** by the Free Software Foundation, either version 3 of the License, or +** (at your option) any later version. +** +** mmg is distributed in the hope that it will be useful, but WITHOUT +** ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or +** FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public +** License for more details. +** +** You should have received a copy of the GNU Lesser General Public +** License and of the GNU General Public License along with mmg (in +** files COPYING.LESSER and COPYING). If not, see +** . Please read their terms carefully and +** use this copy of the mmg distribution only if you accept them. +** ============================================================================= +*/ + +namespace Kratos +{ +// The member variables related with the MMG library +MMG5_pMesh mmgMesh; +MMG5_pSol mmgSol; + +/************************************* CONSTRUCTOR *********************************/ +/***********************************************************************************/ + +template< unsigned int TDim> +MmgProcess::MmgProcess( + ModelPart& rThisModelPart, + Parameters ThisParameters + ) + :mrThisModelPart(rThisModelPart), + mThisParameters(ThisParameters) +{ + Parameters DefaultParameters = Parameters(R"( + { + "filename" : "out", + "framework" : "Eulerian", + "internal_variables_parameters" : + { + "allocation_size" : 1000, + "bucket_size" : 4, + "search_factor" : 2, + "interpolation_type" : "LST", + "internal_variable_interpolation_list" :[] + }, + "save_external_files" : false, + "max_number_of_searchs" : 1000, + "echo_level" : 3, + "step_data_size" : 0, + "buffer_size" : 0 + })" ); + + mThisParameters.ValidateAndAssignDefaults(DefaultParameters); + + mStdStringFilename = mThisParameters["filename"].GetString(); + mEchoLevel = mThisParameters["echo_level"].GetInt(); + + mFilename = new char [mStdStringFilename.length() + 1]; + std::strcpy (mFilename, mStdStringFilename.c_str()); + + mFramework = ConvertFramework(mThisParameters["framework"].GetString()); + + mpRefElement.clear(); + mpRefCondition.clear(); +} + +/*************************************** EXECUTE ***********************************/ +/***********************************************************************************/ + +template< unsigned int TDim> +void MmgProcess::Execute() +{ + KRATOS_TRY; + + const bool safe_to_file = mThisParameters["save_external_files"].GetBool(); + + /* We restart the MMG mesh and solution */ + InitMesh(); + + /* We print the original model part */ + if (mEchoLevel > 0) + { + std::cout << "//---------------------------------------------------//" << std::endl; + std::cout << "//---------------------------------------------------//" << std::endl; + std::cout << "//--------------- BEFORE REMESHING ---------------//" << std::endl; + std::cout << "//---------------------------------------------------//" << std::endl; + std::cout << "//---------------------------------------------------//" << std::endl << std::endl; + + KRATOS_WATCH(mrThisModelPart); + } + + // We initialize the mesh and solution data + InitializeMeshData(); + InitializeSolData(); + + // Check if the number of given entities match with mesh size + CheckMeshData(); + + // Save to file + if (safe_to_file == true) + { + SaveSolutionToFile(false); + } + + // We execute the remeshing + ExecuteRemeshing(); + + /* We print the resulting model part */ + if (mEchoLevel > 0) + { + std::cout << "//---------------------------------------------------//" << std::endl; + std::cout << "//---------------------------------------------------//" << std::endl; + std::cout << "//--------------- AFTER REMESHING ---------------//" << std::endl; + std::cout << "//---------------------------------------------------//" << std::endl; + std::cout << "//---------------------------------------------------//" << std::endl << std::endl; + + KRATOS_WATCH(mrThisModelPart); + } + + KRATOS_CATCH(""); +} + +/************************************* OPERATOR() **********************************/ +/***********************************************************************************/ + +template< unsigned int TDim> +void MmgProcess::operator()() +{ + Execute(); +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +void MmgProcess::InitializeMeshData() +{ + // First we compute the colors + std::unordered_map nodes_colors, cond_colors, elem_colors; + ComputeColors(nodes_colors, cond_colors, elem_colors); + + /////////* MESH FILE *///////// + // Build mesh in MMG5 format // + + // Iterate in the nodes + NodesArrayType& nodes_array = mrThisModelPart.Nodes(); + const SizeType num_nodes = nodes_array.end() - nodes_array.begin(); + + // Iterate in the conditions + ConditionsArrayType& conditions_array = mrThisModelPart.Conditions(); + const SizeType num_conditions = conditions_array.end() - conditions_array.begin(); + + // Iterate in the elements + ElementsArrayType& elements_array = mrThisModelPart.Elements(); + const SizeType num_elements = elements_array.end() - elements_array.begin(); + + /* Manually set of the mesh */ + array_1d num_array_elements; + array_1d num_array_conditions; + if (TDim == 2) + { + num_array_conditions[0] = num_conditions; + num_array_elements[0] = num_elements; + } + else + { + // We initialize the values + num_array_elements[0] = 0; // Tetrahedron + num_array_elements[1] = 0; // Prisms + + num_array_conditions[0] = 0; // Triangles + num_array_conditions[1] = 0; // Quadrilaterals + + /* Elements */ + #pragma omp parallel for + for(int i = 0; i < num_elements; i++) + { + auto it_elem = elements_array.begin() + i; + + if ((it_elem->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Tetrahedra3D4) // Tetrahedron + { + #pragma omp atomic + num_array_elements[0] += 1; + } + else if ((it_elem->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Prism3D6) // Prisms + { + #pragma omp atomic + num_array_elements[1] += 1; + } + else + { + std::cout << "WARNING: YOUR GEOMETRY CONTAINS HEXAEDRON THAT CAN NOT BE REMESHED" << std::endl; + } + } + + if (((num_array_elements[0] + num_array_elements[1]) < num_elements) && mEchoLevel > 0) + { + std::cout << "Number of Elements: " << num_elements << " Number of Tetrahedron: " << num_array_elements[0] << " Number of Prisms: " << num_array_elements[1] << std::endl; + } + + /* Conditions */ + #pragma omp parallel for + for(int i = 0; i < num_conditions; i++) + { + auto it_cond = conditions_array.begin() + i; + + if ((it_cond->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Triangle3D3) // Triangles + { + #pragma omp atomic + num_array_conditions[0] += 1; + } + else if ((it_cond->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Quadrilateral3D4) // Quadrilaterals + { + #pragma omp atomic + num_array_conditions[1] += 1; + } + } + } + + SetMeshSize(num_nodes, num_array_elements, num_array_conditions); + + /* Nodes */ + // We copy the DOF from the first node (after we release, to avoid problem with previous conditions) + mDofs = nodes_array.begin()->GetDofs(); + for (typename Node<3>::DofsContainerType::const_iterator it_dof = mDofs.begin(); it_dof != mDofs.end(); it_dof++) + { + it_dof->FreeDof(); + } + + #pragma omp parallel for firstprivate(nodes_colors) + for(SizeType i = 0; i < num_nodes; i++) + { + auto it_node = nodes_array.begin() + i; + + SetNodes(it_node->X(), it_node->Y(), it_node->Z(), nodes_colors[it_node->Id()], i + 1); + + bool blocked = false; + if (it_node->IsDefined(BLOCKED) == true) + { + blocked = it_node->Is(BLOCKED); + } + if (TDim == 3 && blocked == true) + { + BlockNode(i + 1); + } + + // RESETING THE ID OF THE NODES (important for non consecutive meshes) + it_node->SetId(i + 1); + } + + /* Conditions */ + #pragma omp parallel for firstprivate(cond_colors) + for(SizeType i = 0; i < num_conditions; i++) + { + auto it_cond = conditions_array.begin() + i; + + SetConditions(it_cond->GetGeometry(), cond_colors[it_cond->Id()], i + 1); + } + + /* Elements */ + #pragma omp parallel for firstprivate(elem_colors) + for(SizeType i = 0; i < num_elements; i++) + { + auto it_elem = elements_array.begin() + i; + + SetElements(it_elem->GetGeometry(), elem_colors[it_elem->Id()], i + 1); + } + + /* We clone the first condition and element of each type (we will assume that each sub model part has just one kind of condition, in my opinion it is quite reccomended to create more than one sub model part if you have more than one element or condition) */ + // First we add the main model part + bool to_check_cond = false; + bool to_check_elem = false; + if (num_conditions > 0) + { + mpRefCondition[0] = conditions_array.begin()->Create(0, conditions_array.begin()->GetGeometry(), conditions_array.begin()->pGetProperties()); + to_check_cond = true; + } + if (num_elements > 0) + { + mpRefElement[0] = elements_array.begin()->Create(0, elements_array.begin()->GetGeometry(), elements_array.begin()->pGetProperties()); + to_check_elem = true; + } + // Now we iterate over the model parts + for (auto & color_list : mColors) + { + const int key = color_list.first; + + if (((to_check_cond == false) && (to_check_elem == false)) == true) break; + + if (key != 0) // NOTE: key == 0 is the MainModelPart + { + bool cond_added = false; + bool elem_added = false; + + for (auto sub_model_part_name : color_list.second) + { + ModelPart& r_sub_model_part = mrThisModelPart.GetSubModelPart(sub_model_part_name); + + if (to_check_cond == true) + { + ConditionsArrayType& conditions_array_sub_model_part = r_sub_model_part.Conditions(); + const SizeType num_conditions_sub_model_part = conditions_array_sub_model_part.end() - conditions_array_sub_model_part.begin(); + + if (num_conditions_sub_model_part > 0) + { + mpRefCondition[key] = conditions_array_sub_model_part.begin()->Create(0, conditions_array_sub_model_part.begin()->GetGeometry(), conditions_array_sub_model_part.begin()->pGetProperties()); + cond_added = true; + } + } + if (to_check_elem == true) + { + ElementsArrayType& elements_array_sub_model_part = r_sub_model_part.Elements(); + const SizeType num_elements_sub_model_part = elements_array_sub_model_part.end() - elements_array_sub_model_part.begin(); + + if (num_elements_sub_model_part > 0) + { + mpRefElement[key] = elements_array_sub_model_part.begin()->Create(0, elements_array_sub_model_part.begin()->GetGeometry(), elements_array_sub_model_part.begin()->pGetProperties()); + elem_added = true; + } + } + + if ((cond_added && elem_added) == true) break; + } + } + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template< unsigned int TDim> +void MmgProcess::InitializeSolData() +{ + ////////* SOLUTION FILE *//////// + + // Iterate in the nodes + NodesArrayType& nodes_array = mrThisModelPart.Nodes(); + const SizeType num_nodes = nodes_array.end() - nodes_array.begin(); + + SetSolSizeTensor(num_nodes); + + #pragma omp parallel for + for(SizeType i = 0; i < num_nodes; i++) + { + auto it_node = nodes_array.begin() + i; + + #ifdef KRATOS_DEBUG + if( it_node->Has(MMG_METRIC) == false) + { + KRATOS_ERROR << " MMG_METRIC not defined for node " << it_node->Id(); + } + #endif + + // We get the metric + const Vector& metric = it_node->GetValue(MMG_METRIC); + + #ifdef KRATOS_DEBUG + if(metric.size() != TDim * 3 - 3) + { + KRATOS_ERROR << "Wrong size of vector MMG_METRIC found for node " << it_node->Id() << " size is " << metric.size() << " expected size was " << TDim * 3 - 3; + } + #endif + + // We set the metric + SetMetricTensor(metric, i + 1); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +void MmgProcess::ExecuteRemeshing() +{ + // Getting the parameters + const bool save_to_file = mThisParameters["save_external_files"].GetBool(); + + // We initialize some values + const SizeType step_data_size = mrThisModelPart.GetNodalSolutionStepDataSize(); + const SizeType buffer_size = mrThisModelPart.NodesBegin()->GetBufferSize(); + + mThisParameters["step_data_size"].SetInt(step_data_size); + mThisParameters["buffer_size"].SetInt(buffer_size); + + if (mEchoLevel > 0) + { + std::cout << "Step data size: " << step_data_size << " Buffer size: " << buffer_size << std::endl; + } + + ////////* MMG LIBRARY CALL *//////// + if (mEchoLevel > 0) + { + std::cout << "////////* MMG LIBRARY CALL *////////" << std::endl; + } + + MMGLibCall(); + + const unsigned int n_nodes = mmgMesh->np; + array_1d n_conditions; + if (TDim == 2) + { + n_conditions[0] = mmgMesh->na; + n_conditions[1] = 0; + } + else + { + n_conditions[0] = mmgMesh->nt; + n_conditions[1] = mmgMesh->nquad; + } + array_1d n_elements; + if (TDim == 2) + { + n_elements[0] = mmgMesh->nt; + n_elements[1] = 0; + } + else + { + n_elements[0] = mmgMesh->ne; + n_elements[1] = mmgMesh->nprism; + } + + if (mEchoLevel > 0) + { + std::cout << " Nodes created: " << n_nodes << std::endl; + if (TDim == 2) // 2D + { + std::cout << "Conditions created: " << n_conditions[0] << std::endl; + std::cout << "Elements created: " << n_elements[0] << std::endl; + } + else // 3D + { + std::cout << "Conditions created: " << n_conditions[0] + n_conditions[1] << std::endl; + std::cout << "\tTriangles: " << n_conditions[0] << "\tQuadrilaterals: " << n_conditions[1]<< std::endl; + std::cout << "Elements created: " << n_elements[0] + n_elements[1] << std::endl; + std::cout << "\tTetrahedron: " << n_elements[0] << "\tPrisms: " << n_elements[1] << std::endl; + } + } + + ////////* EMPTY AND BACKUP THE MODEL PART *//////// + + ModelPart r_old_model_part; + + // First we empty the model part + NodesArrayType& nodes_array = mrThisModelPart.Nodes(); + const SizeType num_nodes = nodes_array.end() - nodes_array.begin(); + + #pragma omp parallel for + for(SizeType i = 0; i < num_nodes; i++) + { + auto it_node = nodes_array.begin() + i; + + it_node->Set(TO_ERASE, true); + } + r_old_model_part.AddNodes( mrThisModelPart.NodesBegin(), mrThisModelPart.NodesEnd() ); + mrThisModelPart.RemoveNodesFromAllLevels(TO_ERASE); + + ConditionsArrayType& conditions_array = mrThisModelPart.Conditions(); + const SizeType num_conditions = conditions_array.end() - conditions_array.begin(); + + #pragma omp parallel for + for(SizeType i = 0; i < num_conditions; i++) + { + auto it_cond = conditions_array.begin() + i; + + it_cond->Set(TO_ERASE, true); + } + r_old_model_part.AddConditions( mrThisModelPart.ConditionsBegin(), mrThisModelPart.ConditionsEnd() ); + mrThisModelPart.RemoveConditionsFromAllLevels(TO_ERASE); + + ElementsArrayType& elements_array = mrThisModelPart.Elements(); + const SizeType num_elements = elements_array.end() - elements_array.begin(); + + #pragma omp parallel for + for(SizeType i = 0; i < num_elements; i++) + { + auto it_elem = elements_array.begin() + i; + + it_elem->Set(TO_ERASE, true); + } + r_old_model_part.AddElements( mrThisModelPart.ElementsBegin(), mrThisModelPart.ElementsEnd() ); + mrThisModelPart.RemoveElementsFromAllLevels(TO_ERASE); + + // Create a new model part // TODO: Use a different kind of element for each submodelpart (in order to be able of remeshing more than one kind o element or condition) + std::unordered_map> color_nodes; + std::unordered_map> color_cond_0; + std::unordered_map> color_cond_1; + std::unordered_map> color_elem_0; + std::unordered_map> color_elem_1; + + /* NODES */ // TODO: ADD OMP + for (unsigned int i_node = 1; i_node <= n_nodes; i_node++) + { + int ref, is_required; + NodeType::Pointer p_node = CreateNode(i_node, ref, is_required); + + // Set the DOFs in the nodes + for (typename NodeType::DofsContainerType::const_iterator it_dof = mDofs.begin(); it_dof != mDofs.end(); it_dof++) + { + p_node->pAddDof(*it_dof); + } + + if (ref != 0) color_nodes[ref].push_back(i_node);// NOTE: ref == 0 is the MainModelPart + } + + // Auxiliar values + int prop_id, is_required; + + /* CONDITIONS */ // TODO: ADD OMP + if (mpRefCondition.size() > 0) + { + unsigned int cond_id = 1; + + unsigned int counter_cond_0 = 0; + const std::vector condition_to_remove_0 = CheckConditions0(); + for (unsigned int i_cond = 1; i_cond <= n_conditions[0]; i_cond++) + { + bool skip_creation = false; + if (counter_cond_0 < condition_to_remove_0.size()) + { + if (condition_to_remove_0[counter_cond_0] == i_cond) + { + skip_creation = true; + counter_cond_0 += 1; + } + } + ConditionType::Pointer p_condition = CreateCondition0(cond_id, prop_id, is_required, skip_creation); + + if (p_condition != nullptr) + { + mrThisModelPart.AddCondition(p_condition); + + if (prop_id != 0) color_cond_0[prop_id].push_back(cond_id);// NOTE: prop_id == 0 is the MainModelPart + + cond_id += 1; + } + } + + unsigned int counter_cond_1 = 0; + const std::vector condition_to_remove_1 = CheckConditions1(); + for (unsigned int i_cond = 1; i_cond <= n_conditions[1]; i_cond++) + { + bool skip_creation = false; + if (counter_cond_1 < condition_to_remove_1.size()) + { + if (condition_to_remove_1[counter_cond_1] == i_cond) + { + skip_creation = true; + counter_cond_1 += 1; + } + } + ConditionType::Pointer p_condition = CreateCondition1(cond_id, prop_id, is_required, skip_creation); + + if (p_condition != nullptr) + { + mrThisModelPart.AddCondition(p_condition); + + if (prop_id != 0) color_cond_1[prop_id].push_back(cond_id);// NOTE: prop_id == 0 is the MainModelPart + + cond_id += 1; + } + } + } + + /* ELEMENTS */ // TODO: ADD OMP + if (mpRefElement.size() > 0) + { + unsigned int elem_id = 1; + + unsigned int counter_elem_0 = 0; + const std::vector elements_to_remove_0 = CheckElements0(); + for (unsigned int i_elem = 1; i_elem <= n_elements[0]; i_elem++) + { + bool skip_creation = false; + if (counter_elem_0 < elements_to_remove_0.size()) + { + if (elements_to_remove_0[counter_elem_0] == i_elem) + { + skip_creation = true; + counter_elem_0 += 1; + } + } + ElementType::Pointer p_element = CreateElement0(elem_id, prop_id, is_required, skip_creation); + + if (p_element != nullptr) + { + mrThisModelPart.AddElement(p_element); + + if (prop_id != 0) color_elem_0[prop_id].push_back(elem_id);// NOTE: prop_id == 0 is the MainModelPart + + elem_id += 1; + } + } + + unsigned int counter_elem_1 = 0; + const std::vector elements_to_remove_1 = CheckElements1(); + for (unsigned int i_elem = 1; i_elem <= n_elements[1]; i_elem++) + { + bool skip_creation = false; + if (counter_elem_1 < elements_to_remove_1.size()) + { + if (elements_to_remove_1[counter_elem_1] == i_elem) + { + skip_creation = true; + counter_elem_1 += 1; + } + } + ElementType::Pointer p_element = CreateElement1(elem_id, prop_id, is_required,skip_creation); + + if (p_element != nullptr) + { + mrThisModelPart.AddElement(p_element); + + if (prop_id != 0) color_elem_1[prop_id].push_back(elem_id);// NOTE: prop_id == 0 is the MainModelPart + + elem_id += 1; + } + } + } + + // We add nodes, conditions and elements to the sub model parts + for (auto & color_list : mColors) + { + const int key = color_list.first; + if (key != 0) // NOTE: key == 0 is the MainModelPart + { + for (auto sub_model_part_name : color_list.second) + { + ModelPart& r_sub_model_part = mrThisModelPart.GetSubModelPart(sub_model_part_name); + + if (color_nodes.find(key) != color_nodes.end()) r_sub_model_part.AddNodes(color_nodes[key]); + if (color_cond_0.find(key) != color_cond_0.end()) r_sub_model_part.AddConditions(color_cond_0[key]); + if (color_cond_1.find(key) != color_cond_1.end()) r_sub_model_part.AddConditions(color_cond_1[key]); + if (color_elem_0.find(key) != color_elem_0.end()) r_sub_model_part.AddElements(color_elem_0[key]); + if (color_elem_1.find(key) != color_elem_1.end()) r_sub_model_part.AddElements(color_elem_1[key]); + } + } + } + + /* Save to file */ + if (save_to_file == true) + { + SaveSolutionToFile(true); + } + + /* Free memory */ + FreeMemory(); + + /* After that we reorder nodes, conditions and elements: */ + ReorderAllIds(); + + /* We interpolate all the values */ + Parameters InterpolateParameters = Parameters(R"({"echo_level": 1, "framework": "Eulerian", "max_number_of_searchs": 1000, "step_data_size": 0, "buffer_size": 0})" ); + InterpolateParameters["echo_level"].SetInt(mThisParameters["echo_level"].GetInt()); + InterpolateParameters["framework"].SetString(mThisParameters["framework"].GetString()); + InterpolateParameters["max_number_of_searchs"].SetInt(mThisParameters["max_number_of_searchs"].GetInt()); + InterpolateParameters["step_data_size"].SetInt(mThisParameters["step_data_size"].GetInt()); + InterpolateParameters["buffer_size"].SetInt(mThisParameters["buffer_size"].GetInt()); + NodalValuesInterpolationProcess InterpolateNodalValues = NodalValuesInterpolationProcess(r_old_model_part, mrThisModelPart, InterpolateParameters); + InterpolateNodalValues.Execute(); + + /* We initialize elements and conditions */ + InitializeElementsAndConditions(); + + /* We interpolate the internal variables */ + if (mFramework == Lagrangian) + { + InternalVariablesInterpolationProcess InternalVariablesInterpolation = InternalVariablesInterpolationProcess(r_old_model_part, mrThisModelPart, mThisParameters["internal_variables_parameters"]); + InternalVariablesInterpolation.Execute(); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +void MmgProcess::ReorderAllIds() +{ + NodesArrayType& nodes_array = mrThisModelPart.Nodes(); + const SizeType num_nodes = nodes_array.end() - nodes_array.begin(); + + for(SizeType i = 0; i < num_nodes; i++) + { + auto it_node = nodes_array.begin() + i; + it_node->SetId(i + 1); + } + + ConditionsArrayType& condition_array = mrThisModelPart.Conditions(); + const SizeType num_conditions = condition_array.end() - condition_array.begin(); + + for(SizeType i = 0; i < num_conditions; i++) + { + auto it_condition = condition_array.begin() + i; + it_condition->SetId(i + 1); + } + + ElementsArrayType& element_array = mrThisModelPart.Elements(); + const SizeType num_elements = element_array.end() - element_array.begin(); + + for(SizeType i = 0; i < num_elements; i++) + { + auto it_element = element_array.begin() + i; + it_element->SetId(i + 1); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +void MmgProcess::InitializeElementsAndConditions() +{ + ConditionsArrayType& condition_array = mrThisModelPart.Conditions(); + const SizeType num_conditions = condition_array.end() - condition_array.begin(); + + for(SizeType i = 0; i < num_conditions; i++) + { + auto it_condition = condition_array.begin() + i; + it_condition->Initialize(); + } + + ElementsArrayType& element_array = mrThisModelPart.Elements(); + const SizeType num_elements = element_array.end() - element_array.begin(); + + for(SizeType i = 0; i < num_elements; i++) + { + auto it_element = element_array.begin() + i; + it_element->Initialize(); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +std::vector MmgProcess::CheckNodes() +{ + typedef std::unordered_map, unsigned int, KeyHasherRange>, KeyComparorRange> > HashMap; + HashMap node_map; + + std::vector nodes_to_remove_ids; + + std::vector coords(TDim); + + NodesArrayType& nodes_array = mrThisModelPart.Nodes(); + const SizeType num_nodes = nodes_array.end() - nodes_array.begin(); + + for(SizeType i = 0; i < num_nodes; i++) + { + auto it_node = nodes_array.begin() + i; + + const array_1d coordinates = it_node->Coordinates(); + + for(unsigned int i_coord = 0; i_coord < TDim; i_coord++) + { + coords[i_coord] = coordinates[i_coord]; + } + + node_map[coords] += 1; + + if (node_map[coords] > 1) + { + nodes_to_remove_ids.push_back(it_node->Id()); + if (mEchoLevel > 0) + { + std::cout << "The mode " << it_node->Id() << " is repeated"<< std::endl; + } + } + } + + return nodes_to_remove_ids; +} + +template<> +std::vector MmgProcess<2>::CheckConditions0() +{ + typedef std::unordered_map, unsigned int, KeyHasherRange>, KeyComparorRange> > HashMap; + HashMap edge_map; + + std::vector ids(2); + + std::vector conditions_to_remove; + + // Iterate in the conditions + for(int i = 0; i < mmgMesh->na; i++) + { + int edge_0, edge_1, prop_id, is_ridge, is_required; + + if (MMG2D_Get_edge(mmgMesh, &edge_0, &edge_1, &prop_id, &is_ridge, &is_required) != 1 ) + { + exit(EXIT_FAILURE); + } + + ids[0] = edge_0; + ids[1] = edge_1; + + //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** + std::sort(ids.begin(), ids.end()); + + edge_map[ids] += 1; + + if (edge_map[ids] > 1) + { + conditions_to_remove.push_back(i + 1); + } + } + + return conditions_to_remove; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +std::vector MmgProcess<3>::CheckConditions0() +{ + typedef std::unordered_map, unsigned int, KeyHasherRange>, KeyComparorRange> > HashMap; + HashMap triangle_map; + + std::vector ids_triangles(3); + + std::vector conditions_to_remove; + + for(int i = 0; i < mmgMesh->nt; i++) + { + int vertex_0, vertex_1, vertex_2, prop_id, is_required; + + if (MMG3D_Get_triangle(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &prop_id, &is_required) != 1 ) + { + exit(EXIT_FAILURE); + } + + ids_triangles[0] = vertex_0; + ids_triangles[1] = vertex_1; + ids_triangles[2] = vertex_2; + + //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** + std::sort(ids_triangles.begin(), ids_triangles.end()); + + triangle_map[ids_triangles] += 1; + + if (triangle_map[ids_triangles] > 1) + { + conditions_to_remove.push_back(i + 1); + } + } + + return conditions_to_remove; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +std::vector MmgProcess<2>::CheckConditions1() +{ + std::vector conditions_to_remove(0); + + return conditions_to_remove; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +std::vector MmgProcess<3>::CheckConditions1() +{ + typedef std::unordered_map, unsigned int, KeyHasherRange>, KeyComparorRange> > HashMap; + HashMap quadrilateral_map; + + std::vector ids_quadrialteral(4); + + std::vector conditions_to_remove; + + for(int i = 0; i < mmgMesh->nquad; i++) + { + int vertex_0, vertex_1, vertex_2, vertex_3, prop_id, is_required; + + if (MMG3D_Get_quadrilateral(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &vertex_3, &prop_id, &is_required) != 1 ) + { + exit(EXIT_FAILURE); + } + + ids_quadrialteral[0] = vertex_0; + ids_quadrialteral[1] = vertex_1; + ids_quadrialteral[2] = vertex_2; + ids_quadrialteral[3] = vertex_3; + + //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** + std::sort(ids_quadrialteral.begin(), ids_quadrialteral.end()); + + quadrilateral_map[ids_quadrialteral] += 1; + + if (quadrilateral_map[ids_quadrialteral] > 1) + { + conditions_to_remove.push_back(i + 1); + } + } + + return conditions_to_remove; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +std::vector MmgProcess<2>::CheckElements0() +{ + typedef std::unordered_map, unsigned int, KeyHasherRange>, KeyComparorRange> > HashMap; + HashMap triangle_map; + + std::vector ids_triangles(3); + + std::vector elements_to_remove; + + // Iterate in the elements + for(int i = 0; i < mmgMesh->nt; i++) + { + int vertex_0, vertex_1, vertex_2, prop_id, is_required; + + if (MMG2D_Get_triangle(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &prop_id, &is_required) != 1 ) + { + exit(EXIT_FAILURE); + } + + ids_triangles[0] = vertex_0; + ids_triangles[1] = vertex_1; + ids_triangles[2] = vertex_2; + + //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** + std::sort(ids_triangles.begin(), ids_triangles.end()); + + triangle_map[ids_triangles] += 1; + + if (triangle_map[ids_triangles] > 1) + { + elements_to_remove.push_back(i + 1); + } + } + + return elements_to_remove; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +std::vector MmgProcess<3>::CheckElements0() +{ + typedef std::unordered_map, unsigned int, KeyHasherRange>, KeyComparorRange> > HashMap; + HashMap triangle_map; + + std::vector ids_tetrahedron(4); + + std::vector elements_to_remove; + + for(int i = 0; i < mmgMesh->ne; i++) + { + int vertex_0, vertex_1, vertex_2, vertex_3, prop_id, is_required; + + if (MMG3D_Get_tetrahedron(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &vertex_3, &prop_id, &is_required) != 1 ) + { + exit(EXIT_FAILURE); + } + + ids_tetrahedron[0] = vertex_0; + ids_tetrahedron[1] = vertex_1; + ids_tetrahedron[2] = vertex_2; + ids_tetrahedron[3] = vertex_3; + + //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** + std::sort(ids_tetrahedron.begin(), ids_tetrahedron.end()); + + triangle_map[ids_tetrahedron] += 1; + + if (triangle_map[ids_tetrahedron] > 1) + { + elements_to_remove.push_back(i + 1); + } + } + + return elements_to_remove; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +std::vector MmgProcess<2>::CheckElements1() +{ + + std::vector elements_to_remove(0); + + return elements_to_remove; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +std::vector MmgProcess<3>::CheckElements1() +{ + typedef std::unordered_map, unsigned int, KeyHasherRange>, KeyComparorRange> > HashMap; + HashMap prism_map; + + std::vector ids_prisms(6); + + std::vector elements_to_remove; + + for(int i = 0; i < mmgMesh->nprism; i++) + { + int vertex_0, vertex_1, vertex_2, vertex_3, vertex_4, vertex_5, prop_id, is_required; + + if (MMG3D_Get_prism(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &vertex_3, &vertex_4, &vertex_5, &prop_id, &is_required) != 1 ) + { + exit(EXIT_FAILURE); + } + + ids_prisms[0] = vertex_0; + ids_prisms[1] = vertex_1; + ids_prisms[2] = vertex_2; + ids_prisms[3] = vertex_3; + ids_prisms[4] = vertex_4; + ids_prisms[5] = vertex_5; + + //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** + std::sort(ids_prisms.begin(), ids_prisms.end()); + + prism_map[ids_prisms] += 1; + + if (prism_map[ids_prisms] > 1) + { + elements_to_remove.push_back(i + 1); + } + } + + return elements_to_remove; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +// template<> // NOTE: Not yet avalaible in the official API +// void MmgProcess<2>::BlockNode(unsigned int iNode) +// { +// if (MMG2D_Set_requiredVertex(mmgMesh, iNode) != 1 ) +// { +// exit(EXIT_FAILURE); +// } +// } + +/***********************************************************************************/ +/***********************************************************************************/ + + +template<> +void MmgProcess<3>::BlockNode(unsigned int iNode) +{ + if (MMG3D_Set_requiredVertex(mmgMesh, iNode) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +NodeType::Pointer MmgProcess<2>::CreateNode( + unsigned int iNode, + int& Ref, + int& IsRequired + ) +{ + double coord_0, coord_1; + int is_corner; + + if (MMG2D_Get_vertex(mmgMesh, &coord_0, &coord_1, &Ref, &is_corner, &IsRequired) != 1 ) + { + exit(EXIT_FAILURE); + } + + NodeType::Pointer p_node = mrThisModelPart.CreateNewNode(iNode, coord_0, coord_1, 0.0); + + return p_node; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +NodeType::Pointer MmgProcess<3>::CreateNode( + unsigned int iNode, + int& Ref, + int& IsRequired + ) +{ + double coord_0, coord_1, coord_2; + int is_corner; + + if (MMG3D_Get_vertex(mmgMesh, &coord_0, &coord_1, &coord_2, &Ref, &is_corner, &IsRequired) != 1 ) + { + exit(EXIT_FAILURE); + } + + NodeType::Pointer p_node = mrThisModelPart.CreateNewNode(iNode, coord_0, coord_1, coord_2); + + return p_node; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +ConditionType::Pointer MmgProcess<2>::CreateCondition0( + const unsigned int CondId, + int& PropId, + int& IsRequired, + bool SkipCreation + ) +{ + ConditionType::Pointer p_condition = nullptr; + + int edge_0, edge_1, is_ridge; + + if (MMG2D_Get_edge(mmgMesh, &edge_0, &edge_1, &PropId, &is_ridge, &IsRequired) != 1 ) + { + exit(EXIT_FAILURE); + } + + // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum + if (edge_0 == 0) SkipCreation = true; + if (edge_1 == 0) SkipCreation = true; + + if (SkipCreation == false) + { + std::vector condition_nodes (2); + condition_nodes[0] = mrThisModelPart.pGetNode(edge_0); + condition_nodes[1] = mrThisModelPart.pGetNode(edge_1); + + p_condition = mpRefCondition[PropId]->Create(CondId, condition_nodes, mpRefCondition[PropId]->pGetProperties()); + } + else if (mEchoLevel > 0) + { + std::cout << "Condition creation avoided" << std::endl; + } + + return p_condition; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +ConditionType::Pointer MmgProcess<3>::CreateCondition0( + const unsigned int CondId, + int& PropId, + int& IsRequired, + bool SkipCreation + ) +{ + ConditionType::Pointer p_condition = nullptr; + + int vertex_0, vertex_1, vertex_2; + + if (MMG3D_Get_triangle(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &PropId, &IsRequired) != 1 ) + { + exit(EXIT_FAILURE); + } + + // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum + if (vertex_0 == 0) SkipCreation = true; + if (vertex_1 == 0) SkipCreation = true; + if (vertex_2 == 0) SkipCreation = true; + + if (SkipCreation == false) + { + std::vector condition_nodes (3); + condition_nodes[0] = mrThisModelPart.pGetNode(vertex_0); + condition_nodes[1] = mrThisModelPart.pGetNode(vertex_1); + condition_nodes[2] = mrThisModelPart.pGetNode(vertex_2); + + p_condition = mpRefCondition[PropId]->Create(CondId, condition_nodes, mpRefCondition[PropId]->pGetProperties()); + } + else if (mEchoLevel > 0) + { + std::cout << "Condition creation avoided" << std::endl; + } + + return p_condition; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +ConditionType::Pointer MmgProcess<2>::CreateCondition1( + const unsigned int CondId, + int& PropId, + int& IsRequired, + bool SkipCreation + ) +{ + return nullptr; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +ConditionType::Pointer MmgProcess<3>::CreateCondition1( + const unsigned int CondId, + int& PropId, + int& IsRequired, + bool SkipCreation + ) +{ + ConditionType::Pointer p_condition = nullptr; + + int vertex_0, vertex_1, vertex_2, vertex_3; + + if (MMG3D_Get_quadrilateral(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &vertex_3, &PropId, &IsRequired) != 1 ) + { + exit(EXIT_FAILURE); + } + + // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum + if (vertex_0 == 0) SkipCreation = true; + if (vertex_1 == 0) SkipCreation = true; + if (vertex_2 == 0) SkipCreation = true; + if (vertex_3 == 0) SkipCreation = true; + + if (SkipCreation == false) + { + std::vector condition_nodes (4); + condition_nodes[0] = mrThisModelPart.pGetNode(vertex_0); + condition_nodes[1] = mrThisModelPart.pGetNode(vertex_1); + condition_nodes[2] = mrThisModelPart.pGetNode(vertex_2); + condition_nodes[3] = mrThisModelPart.pGetNode(vertex_3); + + p_condition = mpRefCondition[PropId]->Create(CondId, condition_nodes, mpRefCondition[PropId]->pGetProperties()); + } + else if (mEchoLevel > 0) + { + std::cout << "Condition creation avoided" << std::endl; + } + + return p_condition; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +ElementType::Pointer MmgProcess<2>::CreateElement0( + const unsigned int ElemId, + int& PropId, + int& IsRequired, + bool SkipCreation + ) +{ + ElementType::Pointer p_element = nullptr; + + int vertex_0, vertex_1, vertex_2; + + if (MMG2D_Get_triangle(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &PropId, &IsRequired) != 1 ) + { + exit(EXIT_FAILURE); + } + + // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum + if (vertex_0 == 0) SkipCreation = true; + if (vertex_1 == 0) SkipCreation = true; + if (vertex_2 == 0) SkipCreation = true; + + if (SkipCreation == false) + { + std::vector element_nodes (3); + element_nodes[0] = mrThisModelPart.pGetNode(vertex_0); + element_nodes[1] = mrThisModelPart.pGetNode(vertex_1); + element_nodes[2] = mrThisModelPart.pGetNode(vertex_2); + + p_element = mpRefElement[PropId]->Create(ElemId, element_nodes, mpRefElement[PropId]->pGetProperties()); + } + else if (mEchoLevel > 0) + { + std::cout << "Element creation avoided" << std::endl; + } + + return p_element; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +ElementType::Pointer MmgProcess<3>::CreateElement0( + const unsigned int ElemId, + int& PropId, + int& IsRequired, + bool SkipCreation + ) +{ + ElementType::Pointer p_element = nullptr; + + int vertex_0, vertex_1, vertex_2, vertex_3; + + if (MMG3D_Get_tetrahedron(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &vertex_3, &PropId, &IsRequired) != 1 ) + { + exit(EXIT_FAILURE); + } + + // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum + if (vertex_0 == 0) SkipCreation = true; + if (vertex_1 == 0) SkipCreation = true; + if (vertex_2 == 0) SkipCreation = true; + if (vertex_3 == 0) SkipCreation = true; + + if (SkipCreation == false) + { + std::vector element_nodes (4); + element_nodes[0] = mrThisModelPart.pGetNode(vertex_0); + element_nodes[1] = mrThisModelPart.pGetNode(vertex_1); + element_nodes[2] = mrThisModelPart.pGetNode(vertex_2); + element_nodes[3] = mrThisModelPart.pGetNode(vertex_3); + + p_element = mpRefElement[PropId]->Create(ElemId, element_nodes, mpRefElement[PropId]->pGetProperties()); + } + else if (mEchoLevel > 0) + { + std::cout << "Element creation avoided" << std::endl; + } + + return p_element; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +ElementType::Pointer MmgProcess<2>::CreateElement1( + const unsigned int ElemId, + int& PropId, + int& IsRequired, + bool SkipCreation + ) +{ + return nullptr; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +ElementType::Pointer MmgProcess<3>::CreateElement1( + const unsigned int ElemId, + int& PropId, + int& IsRequired, + bool SkipCreation + ) +{ + ElementType::Pointer p_element = nullptr; + + int vertex_0, vertex_1, vertex_2, vertex_3, vertex_4, vertex_5; + + if (MMG3D_Get_prism(mmgMesh, &vertex_0, &vertex_1, &vertex_2, &vertex_3, &vertex_4, &vertex_5, &PropId, &IsRequired) != 1 ) + { + exit(EXIT_FAILURE); + } + + // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum + if (vertex_0 == 0) SkipCreation = true; + if (vertex_1 == 0) SkipCreation = true; + if (vertex_2 == 0) SkipCreation = true; + if (vertex_3 == 0) SkipCreation = true; + if (vertex_4 == 0) SkipCreation = true; + if (vertex_5 == 0) SkipCreation = true; + + if (SkipCreation == false) + { + std::vector element_nodes (6); + element_nodes[0] = mrThisModelPart.pGetNode(vertex_0); + element_nodes[1] = mrThisModelPart.pGetNode(vertex_1); + element_nodes[2] = mrThisModelPart.pGetNode(vertex_2); + element_nodes[3] = mrThisModelPart.pGetNode(vertex_3); + element_nodes[4] = mrThisModelPart.pGetNode(vertex_4); + element_nodes[5] = mrThisModelPart.pGetNode(vertex_5); + + p_element = mpRefElement[PropId]->Create(ElemId, element_nodes, mpRefElement[PropId]->pGetProperties()); + } + else if (mEchoLevel > 0) + { + std::cout << "Element creation avoided" << std::endl; + } + + return p_element; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +void MmgProcess::SaveSolutionToFile(const bool PostOutput) +{ + /* GET RESULTS */ + + const unsigned int& step = mrThisModelPart.GetProcessInfo()[TIME_STEPS]; + + // Automatically save the mesh + OutputMesh(PostOutput, step); + + // Automatically save the solution + OutputSol(PostOutput, step); +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +void MmgProcess::FreeMemory() +{ + // Free the MMG structures + FreeAll(); + + // Free filename (NOTE: Problems with more that one iteration) +// free(mFilename); +// mFilename = nullptr; + + // Free reference std::unordered_map + mpRefElement.clear(); + mpRefCondition.clear(); +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::InitMesh() +{ + mmgMesh = nullptr; + mmgSol = nullptr; + + // We init the MMG mesh and sol + MMG2D_Init_mesh( MMG5_ARG_start, MMG5_ARG_ppMesh, &mmgMesh, MMG5_ARG_ppMet, &mmgSol, MMG5_ARG_end); + + InitVerbosity(); +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::InitMesh() +{ + mmgMesh = nullptr; + mmgSol = nullptr; + + MMG3D_Init_mesh( MMG5_ARG_start, MMG5_ARG_ppMesh, &mmgMesh, MMG5_ARG_ppMet, &mmgSol, MMG5_ARG_end); + + InitVerbosity(); +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +void MmgProcess::InitVerbosity() +{ + /* We set the MMG verbosity */ + int verbosity_mmg; + if (mEchoLevel == 0) + { + verbosity_mmg = 0; + } + else if (mEchoLevel == 1) + { + verbosity_mmg = 0; // NOTE: This way just the essential info from MMG will be printed, but the custom message will appear + } + else if (mEchoLevel == 2) + { + verbosity_mmg = 3; + } + else if (mEchoLevel == 3) + { + verbosity_mmg = 5; + } + else + { + verbosity_mmg = 10; + } + + InitVerbosityParameter(verbosity_mmg); +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::InitVerbosityParameter(const int& VerbosityMMG) +{ + if ( !MMG2D_Set_iparameter(mmgMesh,mmgSol,MMG2D_IPARAM_verbose, VerbosityMMG) ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::InitVerbosityParameter(const int& VerbosityMMG) +{ + if ( !MMG3D_Set_iparameter(mmgMesh,mmgSol,MMG3D_IPARAM_verbose, VerbosityMMG) ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetMeshSize( + const SizeType NumNodes, + const array_1d NumArrayElements, + const array_1d NumArrayConditions + ) +{ + //Give the size of the mesh: NumNodes vertices, num_elements triangles, num_conditions edges (2D) + if ( MMG2D_Set_meshSize(mmgMesh, NumNodes, NumArrayElements[0], NumArrayConditions[0]) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetMeshSize( + const SizeType NumNodes, + const array_1d NumArrayElements, // NOTE: We do this tricky thing to take into account the prisms + const array_1d NumArrayConditions // NOTE: We do this tricky thing to take into account the quadrilaterals + ) +{ + //Give the size of the mesh: NumNodes Vertex, num_elements tetra and prism, NumArrayConditions triangles and quadrilaterals, 0 edges (3D) + if ( MMG3D_Set_meshSize(mmgMesh, NumNodes, NumArrayElements[0], NumArrayElements[1], NumArrayConditions[0], NumArrayConditions[1], 0) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetSolSizeScalar(const int NumNodes) +{ + if ( MMG2D_Set_solSize(mmgMesh,mmgSol,MMG5_Vertex,NumNodes,MMG5_Scalar) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetSolSizeScalar(const int NumNodes) +{ + if ( MMG3D_Set_solSize(mmgMesh,mmgSol,MMG5_Vertex,NumNodes,MMG5_Scalar) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetSolSizeVector(const int NumNodes) +{ + KRATOS_ERROR << "WARNING:: Vector metric not avalaible in 2D" << std::endl; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetSolSizeVector(const int NumNodes) +{ + if ( MMG3D_Set_solSize(mmgMesh,mmgSol,MMG5_Vertex,NumNodes,MMG5_Vector) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetSolSizeTensor(const int NumNodes) +{ + if ( MMG2D_Set_solSize(mmgMesh,mmgSol,MMG5_Vertex,NumNodes,MMG5_Tensor) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetSolSizeTensor(const int NumNodes) +{ + if ( MMG3D_Set_solSize(mmgMesh,mmgSol,MMG5_Vertex,NumNodes,MMG5_Tensor) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::CheckMeshData() +{ + if ( MMG2D_Chk_meshData(mmgMesh, mmgSol) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::CheckMeshData() +{ + if ( MMG3D_Chk_meshData(mmgMesh, mmgSol) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::OutputMesh( + const bool PostOutput, + const unsigned int Step + ) +{ + std::string mesh_name; + if (PostOutput == true) + { + mesh_name = mStdStringFilename+"_step="+std::to_string(Step)+".o.mesh"; + } + else + { + mesh_name = mStdStringFilename+"_step="+std::to_string(Step)+".mesh"; + } + + auto mesh_file = new char [mesh_name.length() + 1]; + std::strcpy (mesh_file, mesh_name.c_str()); + + // a) Give the ouptut mesh name using MMG2D_Set_outputMeshName (by default, the mesh is saved in the "mesh.o.mesh" file + MMG2D_Set_outputMeshName(mmgMesh,mesh_file); + + // b) function calling + if ( MMG2D_saveMesh(mmgMesh,mesh_file) != 1) + { + std::cout << "UNABLE TO SAVE MESH" << std::endl; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::OutputMesh( + const bool PostOutput, + const unsigned int Step + ) +{ + std::string mesh_name; + if (PostOutput == true) + { + mesh_name = mStdStringFilename+"_step="+std::to_string(Step)+".o.mesh"; + } + else + { + mesh_name = mStdStringFilename+"_step="+std::to_string(Step)+".mesh"; + } + + auto mesh_file = new char [mesh_name.length() + 1]; + std::strcpy (mesh_file, mesh_name.c_str()); + + // a) Give the ouptut mesh name using MMG3D_Set_outputMeshName (by default, the mesh is saved in the "mesh.o.mesh" file + MMG3D_Set_outputMeshName(mmgMesh,mesh_file); + + // b) function calling + if ( MMG3D_saveMesh(mmgMesh,mesh_file) != 1) + { + std::cout << "UNABLE TO SAVE MESH" << std::endl; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::OutputSol( + const bool PostOutput, + const unsigned int Step + ) +{ + std::string sol_name; + if (PostOutput == true) + { + sol_name = mStdStringFilename+"_step="+std::to_string(Step)+".o.sol"; + } + else + { + sol_name = mStdStringFilename+"_step="+std::to_string(Step)+".sol"; + } + + auto sol_file = new char [sol_name.length() + 1]; + std::strcpy (sol_file, sol_name.c_str()); + + // a) Give the ouptut sol name using MMG2D_Set_outputSolName (by default, the mesh is saved in the "mesh.o.sol" file + MMG2D_Set_outputSolName(mmgMesh, mmgSol, sol_file); + + // b) Function calling + if ( MMG2D_saveSol(mmgMesh, mmgSol, sol_file) != 1) + { + std::cout << "UNABLE TO SAVE SOL" << std::endl; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::OutputSol( + const bool PostOutput, + const unsigned int Step + ) +{ + std::string sol_name; + if (PostOutput == true) + { + sol_name = mStdStringFilename+"_step="+std::to_string(Step)+".o.sol"; + } + else + { + sol_name = mStdStringFilename+"_step="+std::to_string(Step)+".sol"; + } + + auto sol_file = new char [sol_name.length() + 1]; + std::strcpy (sol_file, sol_name.c_str()); + + // a) Give the ouptut sol name using MMG3D_Set_outputSolName (by default, the mesh is saved in the "mesh.o.sol" file + MMG3D_Set_outputSolName(mmgMesh, mmgSol, sol_file); + + // b) Function calling + if ( MMG3D_saveSol(mmgMesh,mmgSol, sol_file) != 1) + { + std::cout << "UNABLE TO SAVE SOL" << std::endl; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::MMGLibCall() +{ + const int ier = MMG2D_mmg2dlib(mmgMesh, mmgSol); + + if ( ier == MMG5_STRONGFAILURE ) + { + KRATOS_ERROR << "WARNING: BAD ENDING OF MMG2DLIB: UNABLE TO SAVE MESH. ier: " << ier << std::endl; + } + else if ( ier == MMG5_LOWFAILURE ) + { + KRATOS_ERROR << "WARNING: BAD ENDING OF MMG2DLIB. ier: " << ier << std::endl; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::MMGLibCall() +{ + const int ier = MMG3D_mmg3dlib(mmgMesh, mmgSol); + + if ( ier == MMG5_STRONGFAILURE ) + { + KRATOS_ERROR << "WARNING: BAD ENDING OF MMG3DLIB: UNABLE TO SAVE MESH. ier: " << ier << std::endl; + } + else if ( ier == MMG5_LOWFAILURE ) + { + KRATOS_ERROR << "WARNING: BAD ENDING OF MMG3DLIB. ier: " << ier << std::endl; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::FreeAll() +{ + MMG2D_Free_all(MMG5_ARG_start,MMG5_ARG_ppMesh,&mmgMesh,MMG5_ARG_ppMet,&mmgSol,MMG5_ARG_end); +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::FreeAll() +{ + MMG3D_Free_all(MMG5_ARG_start,MMG5_ARG_ppMesh,&mmgMesh,MMG5_ARG_ppMet,&mmgSol,MMG5_ARG_end); +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetNodes( + const double X, + const double Y, + const double Z, + const int Color, + const int Index + ) +{ + if ( MMG2D_Set_vertex(mmgMesh, X, Y, Color, Index) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetNodes( + const double X, + const double Y, + const double Z, + const int Color, + const int Index + ) +{ + if ( MMG3D_Set_vertex(mmgMesh, X, Y, Z, Color, Index) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetConditions( + Geometry > & Geom, + const int Color, + const int Index + ) +{ + if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Point2D) // Point + { + KRATOS_ERROR << "WARNING:: Nodal condition, will be meshed with the node. Condition existence after meshing not guaranteed" << std::endl; + } + else if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Line2D2) // Line + { + const int& id_1 = Geom[0].Id(); // First node id + const int& id_2 = Geom[1].Id(); // Second node id + + if ( MMG2D_Set_edge(mmgMesh, id_1, id_2, Color, Index) != 1 ) + { + exit(EXIT_FAILURE); + } + + // Set fixed boundary + bool blocked_1 = false; + if (Geom[0].IsDefined(BLOCKED) == true) + { + blocked_1 = Geom[0].Is(BLOCKED); + } + bool blocked_2 = false; + if (Geom[1].IsDefined(BLOCKED) == true) + { + blocked_2 = Geom[1].Is(BLOCKED); + } + + if ((blocked_1 && blocked_2) == true) + { + if ( MMG2D_Set_requiredEdge(mmgMesh, Index) != 1 ) + { + exit(EXIT_FAILURE); + } + } + } + else + { + const unsigned int size_geometry = Geom.size(); + KRATOS_ERROR << "WARNING: I DO NOT KNOW WHAT IS THIS. Size: " << size_geometry << " Type: " << Geom.GetGeometryType() << std::endl; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetConditions( + Geometry > & Geom, + const int Color, + const int Index + ) +{ + if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Point3D) // Point + { + KRATOS_ERROR << "WARNING:: Nodal condition, will be meshed with the node. Condition existence after meshing not guaranteed" << std::endl; + } + else if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Line3D2) // Line + { + KRATOS_ERROR << "Kratos_Line3D2 remeshing pending to be implemented" << std::endl; +// const int id1 = Geom[0].Id(); // First node id +// const int id2 = Geom[1].Id(); // Second node id +// +// if ( MMG3D_Set_edge(mmgMesh, id1, id2, Color, Index) != 1 ) +// { +// exit(EXIT_FAILURE); +// } +// +// // Set fixed boundary +// bool blocked_1 = false; +// if (Geom[0].IsDefined(BLOCKED) == true) +// { +// blocked_1 = Geom[0].Is(BLOCKED); +// } +// bool blocked_2 = false; +// if (Geom[1].IsDefined(BLOCKED) == true) +// { +// blocked_2 = Geom[1].Is(BLOCKED); +// } +// +// if ((blocked_1 && blocked_2) == true) +// { +// if ( MMG3D_Set_requiredEdge(mmgMesh, Index) != 1 ) +// { +// exit(EXIT_FAILURE); +// } +// } + } + else if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Triangle3D3) // Triangle + { + const int& id_1 = Geom[0].Id(); // First node Id + const int& id_2 = Geom[1].Id(); // Second node Id + const int& id_3 = Geom[2].Id(); // Third node Id + + if ( MMG3D_Set_triangle(mmgMesh, id_1, id_2, id_3, Color, Index) != 1 ) + { + exit(EXIT_FAILURE); + } + + // Set fixed boundary + bool blocked_1 = false; + if (Geom[0].IsDefined(BLOCKED) == true) + { + blocked_1 = Geom[0].Is(BLOCKED); + } + bool blocked_2 = false; + if (Geom[1].IsDefined(BLOCKED) == true) + { + blocked_2 = Geom[1].Is(BLOCKED); + } + bool blocked_3 = false; + if (Geom[2].IsDefined(BLOCKED) == true) + { + blocked_3 = Geom[2].Is(BLOCKED); + } + + if ((blocked_1 && blocked_2 && blocked_3) == true) + { + if ( MMG3D_Set_requiredTriangle(mmgMesh, Index) != 1 ) + { + exit(EXIT_FAILURE); + } + } + } + else if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Quadrilateral3D4) // Quadrilaterals + { + const int& id_1 = Geom[0].Id(); // First node Id + const int& id_2 = Geom[1].Id(); // Second node Id + const int& id_3 = Geom[2].Id(); // Third node Id + const int& id_4 = Geom[3].Id(); // Fourth node Id + + if ( MMG3D_Set_quadrilateral(mmgMesh, id_1, id_2, id_3, id_4, Color, Index) != 1 ) + { + exit(EXIT_FAILURE); + } + } + else + { + const unsigned int size_geometry = Geom.size(); + KRATOS_ERROR << "WARNING: I DO NOT KNOW WHAT IS THIS. Size: " << size_geometry << " Type: " << Geom.GetGeometryType() << std::endl; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetElements( + Geometry > & Geom, + const int Color, + const int Index + ) +{ + const int& id_1 = Geom[0].Id(); // First node Id + const int& id_2 = Geom[1].Id(); // Second node Id + const int& id_3 = Geom[2].Id(); // Third node Id + + if ( MMG2D_Set_triangle(mmgMesh, id_1, id_2, id_3, Color, Index) != 1 ) + { + exit(EXIT_FAILURE); + } + +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetElements( + Geometry > & Geom, + const int Color, + const int Index + ) +{ + const int& id_1 = Geom[0].Id(); // First node Id + const int& id_2 = Geom[1].Id(); // Second node Id + const int& id_3 = Geom[2].Id(); // Third node Id + const int& id_4 = Geom[3].Id(); // Fourth node Id + + if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Tetrahedra3D4) // Tetrahedron + { + if ( MMG3D_Set_tetrahedron(mmgMesh, id_1, id_2, id_3, id_4, Color, Index) != 1 ) + { + exit(EXIT_FAILURE); + } + } + else if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Prism3D6) // Prisms + { + const int& id_5 = Geom[4].Id(); // 5th node Id + const int& id_6 = Geom[5].Id(); // 6th node Id + + if ( MMG3D_Set_prism(mmgMesh, id_1, id_2, id_3, id_4, id_5, id_6, Color, Index) != 1 ) + { + exit(EXIT_FAILURE); + } + } + else if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Hexahedra3D8) // Hexaedron + { +// const int id_5 = Geom[4].Id(); // 5th node Id +// const int id_6 = Geom[5].Id(); // 6th node Id +// const int id_6 = Geom[7].Id(); // 7th node Id +// const int id_6 = Geom[8].Id(); // 8th node Id + + const unsigned int size_geometry = Geom.size(); + KRATOS_ERROR << "WARNING: HEXAEDRON NON IMPLEMENTED IN THE LIBRARY " << size_geometry << std::endl; + } + else + { + const unsigned int size_geometry = Geom.size(); + KRATOS_ERROR << "WARNING: I DO NOT KNOW WHAT IS THIS. Size: " << size_geometry << std::endl; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +void MmgProcess::ComputeColors( + std::unordered_map& NodesColors, + std::unordered_map& CondColors, + std::unordered_map& ElemColors + ) +{ + // Initialize and create the auxiliar maps + const std::vector sub_model_part_names = mrThisModelPart.GetSubModelPartNames(); + std::unordered_map> aux_nodes_colors, aux_cond_colors, aux_elem_colors; + + std::vector model_part_names; + model_part_names.push_back(mrThisModelPart.Name()); + for (const auto & sub_model_part_name : sub_model_part_names) + { + model_part_names.push_back(sub_model_part_name); + } + + // Initialize Colors + int color = 0; + for (SizeType i_sub_model_part = 0; i_sub_model_part < model_part_names.size(); i_sub_model_part++) + { + mColors[i_sub_model_part].push_back(model_part_names[i_sub_model_part]); + + if (color > 0) + { + ModelPart& r_sub_model_part = mrThisModelPart.GetSubModelPart(model_part_names[i_sub_model_part]); + + // Iterate in the nodes + NodesArrayType& nodes_array = r_sub_model_part.Nodes(); + const SizeType num_nodes = nodes_array.end() - nodes_array.begin(); + + // Iterate in the conditions + ConditionsArrayType& conditions_array = r_sub_model_part.Conditions(); + const SizeType num_conditions = conditions_array.end() - conditions_array.begin(); + + // Iterate in the elements + ElementsArrayType& elements_array = r_sub_model_part.Elements(); + const SizeType num_elements = elements_array.end() - elements_array.begin(); + + #pragma omp parallel + { + std::unordered_map> aux_nodes_colors_partial, aux_cond_colors_partial, aux_elem_colors_partial; + + /* Nodes */ + #pragma omp for + for(SizeType i = 0; i < num_nodes; i++) + { + auto it_node = nodes_array.begin() + i; + aux_nodes_colors_partial[it_node->Id()].insert(color); + } + + /* Conditions */ + #pragma omp for + for(SizeType i = 0; i < num_conditions; i++) + { + auto it_cond = conditions_array.begin() + i; + aux_cond_colors_partial[it_cond->Id()].insert(color); + } + + /* Elements */ + #pragma omp for + for(SizeType i = 0; i < num_elements; i++) + { + auto it_elem = elements_array.begin() + i; + aux_elem_colors_partial[it_elem->Id()].insert(color); + } + + #pragma omp critical + aux_nodes_colors.insert(aux_nodes_colors_partial.begin(), aux_nodes_colors_partial.end()); + #pragma omp critical + aux_cond_colors.insert(aux_cond_colors_partial.begin(), aux_cond_colors_partial.end()); + #pragma omp critical + aux_elem_colors.insert(aux_elem_colors_partial.begin(), aux_elem_colors_partial.end()); + } + } + + color += 1; + } + + // Now detect all the cases in which a node or a cond belongs to more than one part simultaneously + std::unordered_map, int, KeyHasherRange>, KeyComparorRange> > combinations; + + /* Nodes */ + for(auto & aux_nodes_color : aux_nodes_colors) + { + const std::set value = aux_nodes_color.second; + + if (value.size() > 1) + { + combinations[value] = -1; + } + } + + /* Conditions */ + for(auto & aux_cond_color : aux_cond_colors) + { + const std::set value = aux_cond_color.second; + + if (value.size() > 1) + { + combinations[value] = -1; + } + } + + /* Elements */ + for(auto & aux_elem_color : aux_elem_colors) + { + const std::set value = aux_elem_color.second; + + if (value.size() > 1) + { + combinations[value] = -1; + } + } + + /* Combinations */ + for(auto & combination : combinations) + { + const std::set key = combination.first; + + for(int it : key) + { + mColors[color].push_back(mColors[it][0]); + } + combinations[key] = color; + color += 1; + } + + // The final maps are created + /* Nodes */ + for(auto & aux_nodes_color : aux_nodes_colors) + { + const int key = aux_nodes_color.first; + const std::set value = aux_nodes_color.second; + + if (value.size() == 0) + { + NodesColors[key] = 0; // Main Model Part + } + else if (value.size() == 1) // Another Model Part + { + NodesColors[key] = *value.begin(); + } + else // There is a combination + { + NodesColors[key] = combinations[value]; + } + } + + /* Conditions */ + for(auto & aux_cond_color : aux_cond_colors) + { + const int key = aux_cond_color.first; + const std::set value = aux_cond_color.second; + + if (value.size() == 0) + { + CondColors[key] = 0; // Main Model Part + } + else if (value.size() == 1) // Another Model Part + { + CondColors[key] = *value.begin(); + } + else // There is a combination + { + CondColors[key] = combinations[value]; + } + } + + /* Elements */ + for(auto & aux_elem_color : aux_elem_colors) + { + const int key = aux_elem_color.first; + const std::set value = aux_elem_color.second; + + if (value.size() == 0) + { + ElemColors[key] = 0; // Main Model Part + } + else if (value.size() == 1) // Another Model Part + { + ElemColors[key] = *value.begin(); + } + else // There is a combination + { + ElemColors[key] = combinations[value]; + } + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetMetricScalar( + const double& Metric, + const int NodeId + ) +{ + if ( MMG2D_Set_scalarSol(mmgSol, Metric, NodeId) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetMetricScalar( + const double& Metric, + const int NodeId + ) +{ + if ( MMG3D_Set_scalarSol(mmgSol, Metric, NodeId) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetMetricVector( + const array_1d& Metric, + const int NodeId + ) +{ + KRATOS_ERROR << "WARNING:: Vector metric not avalaible in 2D" << std::endl; +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetMetricVector( + const array_1d& Metric, + const int NodeId + ) +{ + if ( MMG3D_Set_vectorSol(mmgSol, Metric[0], Metric[1], Metric[2], NodeId) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<2>::SetMetricTensor( + const Vector& Metric, + const int NodeId + ) +{ + if ( MMG2D_Set_tensorSol(mmgSol, Metric[0], Metric[1], Metric[2], NodeId) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template<> +void MmgProcess<3>::SetMetricTensor( + const Vector& Metric, + const int NodeId + ) +{ + if ( MMG3D_Set_tensorSol(mmgSol, Metric[0], Metric[1], Metric[2], Metric[3], Metric[4], Metric[5], NodeId) != 1 ) + { + exit(EXIT_FAILURE); + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template +FrameworkEulerLagrange MmgProcess::ConvertFramework(const std::string& str) +{ + if(str == "Lagrangian") + { + return Lagrangian; + } + else if(str == "Eulerian") + { + return Eulerian; + } + else + { + return Eulerian; + } +} + +/***********************************************************************************/ +/***********************************************************************************/ + +template class MmgProcess<2>; +template class MmgProcess<3>; + +}// namespace Kratos. diff --git a/applications/MeshingApplication/custom_processes/mmg_process.h b/applications/MeshingApplication/custom_processes/mmg_process.h new file mode 100644 index 000000000000..6ad34fc48b3f --- /dev/null +++ b/applications/MeshingApplication/custom_processes/mmg_process.h @@ -0,0 +1,721 @@ +// KRATOS __ __ _____ ____ _ _ ___ _ _ ____ +// | \/ | ____/ ___|| | | |_ _| \ | |/ ___| +// | |\/| | _| \___ \| |_| || || \| | | _ +// | | | | |___ ___) | _ || || |\ | |_| | +// |_| |_|_____|____/|_| |_|___|_| \_|\____| APPLICATION +// +// License: BSD License +// license: MeshingApplication/license.txt +// +// Main authors: Vicente Mataix Ferrándiz +// + +#if !defined(KRATOS_MMG_PROCESS) +#define KRATOS_MMG_PROCESS + +// System includes +#include + +// External includes +// The includes related with the MMG library +// #include "mmg/libmmg.h" + +// Project includes +#include "processes/process.h" +#include "includes/model_part.h" +#include "includes/kratos_parameters.h" +#include "containers/variables_list.h" + +// NOTE: The following contains the license of the MMG library +/* ============================================================================= +** Copyright (c) Bx INP/Inria/UBordeaux/UPMC, 2004- . +** +** mmg is free software: you can redistribute it and/or modify it +** under the terms of the GNU Lesser General Public License as published +** by the Free Software Foundation, either version 3 of the License, or +** (at your option) any later version. +** +** mmg is distributed in the hope that it will be useful, but WITHOUT +** ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or +** FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public +** License for more details. +** +** You should have received a copy of the GNU Lesser General Public +** License and of the GNU General Public License along with mmg (in +** files COPYING.LESSER and COPYING). If not, see +** . Please read their terms carefully and +** use this copy of the mmg distribution only if you accept them. +** ============================================================================= +*/ + +namespace Kratos +{ +///@name Kratos Globals +///@{ + +///@} +///@name Type Definitions +///@{ + + // Containers definition + typedef ModelPart::NodesContainerType NodesArrayType; + typedef ModelPart::ElementsContainerType ElementsArrayType; + typedef ModelPart::ConditionsContainerType ConditionsArrayType; + + // Components definition + typedef Node <3> NodeType; + typedef Properties PropertiesType; + typedef Element ElementType; + typedef Condition ConditionType; + + // Index defintion + typedef std::size_t IndexType; + typedef std::size_t SizeType; + + // DoF definition + typedef Dof DofType; + + // Mesh definition + typedef Mesh MeshType; + typedef MeshType::PropertiesContainerType PropertiesContainerType; + typedef MeshType::NodeConstantIterator NodeConstantIterator; + typedef MeshType::ConditionConstantIterator ConditionConstantIterator; + typedef MeshType::ElementConstantIterator ElementConstantIterator; + + #if !defined(HASH_COMBINE) + #define HASH_COMBINE + template + inline void HashCombine(std::size_t& Seed, const TClassType& Value) + { + std::hash hasher; + Seed ^= hasher(Value) + 0x9e3779b9 + (Seed<<6) + (Seed>>2); + } + #endif + + #if !defined(HASH_RANGE) + #define HASH_RANGE + template + inline std::size_t HashRange(TClassType First, TClassType Last) + { + std::size_t seed = 0; + + while (First!=Last) + { + HashCombine(seed, *First); + ++First; + } + + return seed; + } + #endif + + #if !defined(KEY_COMPAROR_RANGE) + #define KEY_COMPAROR_RANGE + template + struct KeyComparorRange + { + bool operator()(const TClassType& lhs, const TClassType& rhs) const + { + if(lhs.size() != rhs.size()) + { + return false; + } + + auto it_lhs = lhs.begin(); + auto it_rhs = rhs.begin(); + + while(it_lhs != lhs.end()) // NOTE: We already checked that are same size + { + if(*it_lhs != *it_rhs) + { + return false; + } + if(it_lhs != lhs.end()) + { + ++it_lhs; + ++it_rhs; + } + } + + return true; + } + }; + #endif + + #if !defined(KEY_HASHER_RANGE) + #define KEY_HASHER_RANGE + template + struct KeyHasherRange + { + std::size_t operator()(const TClassType& rRange) const + { + return HashRange(rRange.begin(), rRange.end()); + } + }; + #endif + +///@} +///@name Enum's +///@{ + + /** + * This enums are used to simplify the computation of the std::vector containing the conditions and elements + */ + #if !defined(MMG_GEOMETRY) + #define MMG_GEOMETRY + enum CondGeometries2D {Line = 0}; + + enum ElemGeometries2D {Triangle2D = 0}; + + enum CondGeometries3D {Triangle3D = 0, Quadrilateral3D = 1}; + + enum ElemGeometries3D {Tetrahedra = 0, Prism = 1}; + #endif + + #if !defined(FRAMEWORK_EULER_LAGRANGE) + #define FRAMEWORK_EULER_LAGRANGE + enum FrameworkEulerLagrange {Eulerian = 0, Lagrangian = 1}; + #endif + +///@} +///@name Functions +///@{ + +///@} +///@name Kratos Classes +///@{ + +//// This class is a remesher which uses the MMG library +// The class uses a class for the 2D and 3D cases + +template +class MmgProcess + : public Process +{ +public: + + ///@name Type Definitions + ///@{ + + ///@} + ///@name Life Cycle + ///@{ + + // Constructor + + /** + * This is the default constructor, which is used to read the input files + * @param rThisModelPart: The model part + * @param ThisParameters: The parameters + */ + + MmgProcess(ModelPart& rThisModelPart, Parameters ThisParameters = Parameters(R"({})")); + + /// Destructor. + ~MmgProcess() override = default; + + ///@} + ///@name Access + ///@{ + + ///@} + ///@name Inquiry + ///@{ + + ///@} + ///@name Input and output + ///@{ + + ///@} + ///@name Friends + ///@{ + + ///@} + ///@name Operators + ///@{ + + void operator()(); + + ///@} + ///@name Operations + ///@{ + + /** + * Instead of using an files already created we read an existing model part + */ + + void Execute() override; + + ///@} + ///@name Access + ///@{ + + + ///@} + ///@name Inquiry + ///@{ + + + ///@} + ///@name Input and output + ///@{ + + /// Turn back information as a string. + std::string Info() const override + { + return "MmgProcess"; + } + + /// Print information about this object. + void PrintInfo(std::ostream& rOStream) const override + { + rOStream << "MmgProcess"; + } + + /// Print object's data. + void PrintData(std::ostream& rOStream) const override + { + } + +protected: + + ///@name Protected static Member Variables + ///@{ + + ///@} + ///@name Protected member Variables + ///@{ + + ///@} + ///@name Protected Operators + ///@{ + + ///@} + ///@name Protected Operations + ///@{ + + ///@} + ///@name Protected Access + ///@{ + + ///@} + ///@name Protected Inquiry + ///@{ + + ///@} + ///@name Protected LifeCycle + ///@{ + + ///@} + +private: + ///@name Static Member Variables + ///@{ + + + ///@} + ///@name Member Variables + ///@{ + + // The model part to compute + ModelPart& mrThisModelPart; + + // The parameters (can be used for general pourposes) + Parameters mThisParameters; + + // Storage for the dof of the node + Node<3>::DofsContainerType mDofs; + + // I/O information + char* mFilename; + std::string mStdStringFilename; + unsigned int mEchoLevel; + + // The framework + FrameworkEulerLagrange mFramework; + + // Where the sub model parts IDs are stored + std::unordered_map> mColors; + + // Reference element and condition + std::unordered_map mpRefElement; + std::unordered_map mpRefCondition; + + ///@} + ///@name Private Operators + ///@{ + + ///@} + ///@name Private Operations + ///@{ + + /** + * This function generates the mesh MMG5 structure from a Kratos Model Part + */ + + void InitializeMeshData(); + + /** + * This function generates the metric MMG5 structure from a Kratos Model Part + */ + + void InitializeSolData(); + + /** + * We execute the MMg library and build the new model part from the old model part + */ + + void ExecuteRemeshing(); + + /** + * This function reorder the nodes, conditions and elements to avoid problems with non-consecutive ids + */ + + void ReorderAllIds(); + + /** + * After we have transfer the information from the previous modelpart we initilize the elements and conditions + */ + + void InitializeElementsAndConditions(); + + /** + * It checks if the nodes are repeated and remove the repeated ones + */ + + std::vector CheckNodes(); + + /** + * It checks if the conditions are repeated and remove the repeated ones + */ + + std::vector CheckConditions0(); + std::vector CheckConditions1(); + + /** + * It checks if the elemenst are removed and remove the repeated ones + */ + + std::vector CheckElements0(); + std::vector CheckElements1(); + + /** + * It blocks certain nodes before remesh the model + * @param iNode: The index of the noode + */ + + void BlockNode(unsigned int iNode); + + /** + * It creates the new node + * @param iNode: The index of the new noode + * @param Ref: The submodelpart id + * @param IsRequired: MMG value (I don't know that it does) + * @return pNode: The pointer to the new node created + */ + + NodeType::Pointer CreateNode( + unsigned int iNode, + int& Ref, + int& IsRequired + ); + + /** + * It creates the new condition + * @param CondId: The id of the condition + * @param PropId: The submodelpart id + * @param IsRequired: MMG value (I don't know that it does) + * @return pCondition: The pointer to the new condition created + */ + + ConditionType::Pointer CreateCondition0( + const unsigned int CondId, + int& PropId, + int& IsRequired, + bool SkipCreation + ); + + ConditionType::Pointer CreateCondition1( + const unsigned int CondId, + int& PropId, + int& IsRequired, + bool SkipCreation + ); + + /** + * It creates the new element + * @param CondId: The id of the element + * @param PropId: The submodelpart id + * @param IsRequired: MMG value (I don't know that it does) + * @return pElement: The pointer to the new condition created + */ + + ElementType::Pointer CreateElement0( + const unsigned int ElemId, + int& PropId, + int& IsRequired, + bool SkipCreation + ); + + ElementType::Pointer CreateElement1( + const unsigned int ElemId, + int& PropId, + int& IsRequired, + bool SkipCreation + ); + + /** + * It saves the solution and mesh to files (for debugging pourpose g.e) + * @param PostOutput: If the file to save is after or before remeshing + */ + + void SaveSolutionToFile(const bool PostOutput); + + /** + * It frees the memory used during all the process + */ + + void FreeMemory(); + + /** + * Initialisation of mesh and sol structures args of InitMesh: + * @param MMG5_ARG_start: we start to give the args of a variadic func + * @param MMG5_ARG_ppMesh: next arg will be a pointer over a MMG5_pMesh + * @param &mmgMesh: pointer toward your MMG5_pMesh (that store your mesh) + * @param MMG5_ARG_ppMet: next arg will be a pointer over a MMG5_pSol storing a metric + * @param &mmgSol: pointer toward your MMG5_pSol (that store your metric) + */ + + void InitMesh(); + + /** + * Here the verbosity is set + */ + + void InitVerbosity(); + + /** + * Here the verbosity is set using the API + * @param verbosityMMG: The equivalent verbosity level in the MMG API + */ + + void InitVerbosityParameter(const int& VerbosityMMG); + + /** + * This sets the size of the mesh + * @param NumNodes: Number of nodes + * @param NumElements: Number of Elements + * @param NumConditions: Number of Conditions + */ + + void SetMeshSize( + const SizeType NumNodes, + const array_1d NumArrayElements, // NOTE: We do this tricky thing to take into account the prisms + const array_1d NumArrayConditions // NOTE: We do this tricky thing to take into account the quadrilaterals + ); + + /** + * This sets the size of the solution for the scalar case + * @param NumNodes: Number of nodes + */ + + void SetSolSizeScalar(const int NumNodes); + + /** + * This sets the size of the solution for the vector case + * @param NumNodes: Number of nodes + */ + + void SetSolSizeVector(const int NumNodes); + + /** + * This sets the size of the solution for the tensor case + * @param NumNodes: Number of nodes + */ + + void SetSolSizeTensor(const int NumNodes); + + /** + * This checks the mesh data and prints if it is OK + */ + + void CheckMeshData(); + + /** + * This sets the output mesh + * @param PostOutput: If the ouput file is the solution after take into account the metric or not + * @param step: The step to postprocess + */ + + void OutputMesh( + const bool PostOutput, + const unsigned int Step + ); + + /** + * This sets the output sol + * @param PostOutput: If the ouput file is the solution after take into account the metric or not + * @param step: The step to postprocess + */ + + void OutputSol( + const bool PostOutput, + const unsigned int Step + ); + + /** + * This loads the solution + */ + + void MMGLibCall(); + + /** + * This frees the MMG structures + */ + + void FreeAll(); + + /** + * This sets the nodes of the mesh + * @param X: Coordinate X + * @param Y: Coordinate Y + * @param Z: Coordinate Z + * @param Color: Reference of the node(submodelpart) + * @param Index: The index number of the node + */ + + void SetNodes( + const double X, + const double Y, + const double Z, + const int Color, + const int Index + ); + + /** + * This sets the conditions of the mesh + * @param Geom: The geometry of the condition + * @param Color: Reference of the node(submodelpart) + * @param Index: The index number of the node + */ + + void SetConditions( + Geometry > & Geom, + const int Color, + const int Index + ); + + /** + * This sets elements of the mesh + * @param Geom: The geometry of the element + * @param Color: Reference of the node(submodelpart) + * @param Index: The index number of the node + */ + + void SetElements( + Geometry > & Geom, + const int Color, + const int Index + ); + + /** + * This functions gets the "colors", parts of a model part to process + * @param NodeColors: Map where the submodelparts and nodes are stored + * @param CondColors: Map where the submodelparts and conditions are stored + * @param ElemColors: Map where the submodelparts and elements are stored + */ + + void ComputeColors( + std::unordered_map& NodeColors, + std::unordered_map& CondColors, + std::unordered_map& ElemColors + ); + + /** + * This function is used to compute the metric scalar + * @param Metric: The inverse of the size node + */ + + void SetMetricScalar( + const double& Metric, + const int NodeId + ); + + /** + * This function is used to compute the metric vector (x, y, z) + * @param Metric: This array contains the components of the metric vector + */ + + void SetMetricVector( + const array_1d& Metric, + const int NodeId + ); + + /** + * This function is used to compute the Hessian metric tensor, note that when using the Hessian, more than one metric can be defined simultaneously, so in consecuence we need to define the elipsoid which defines the volume of maximal intersection + * @param Metric: This array contains the components of the metric tensor in the MMG defined order + */ + + void SetMetricTensor( + const Vector& Metric, + const int NodeId + ); + + /** + * This converts the framework string to an enum + * @param Str: The string + * @return FrameworkEulerLagrange: The equivalent enum + */ + + FrameworkEulerLagrange ConvertFramework(const std::string& Str); + + ///@} + ///@name Private Access + ///@{ + + + ///@} + ///@name Private Inquiry + ///@{ + + + ///@} + ///@name Un accessible methods + ///@{ + +// /// Assignment operator. +// MmgProcess& operator=(MmgProcess const& rOther); + +// /// Copy constructor. +// MmgProcess(MmgProcess const& rOther); + + ///@} + +};// class MmgProcess +///@} + +///@name Type Definitions +///@{ + + +///@} +///@name Input and output +///@{ + +/// input stream function +// inline std::istream& operator >> (std::istream& rIStream, +// MmgProcess& rThis); +// +// /// output stream function +// inline std::ostream& operator << (std::ostream& rOStream, +// const MmgProcess& rThis) +// { +// rThis.PrintInfo(rOStream); +// rOStream << std::endl; +// rThis.PrintData(rOStream); +// +// return rOStream; +// } + +}// namespace Kratos. +#endif /* KRATOS_MMG_PROCESS defined */ diff --git a/applications/MeshingApplication/custom_processes/nodal_values_interpolation_process.h b/applications/MeshingApplication/custom_processes/nodal_values_interpolation_process.h index 717034314dd0..03a3b981146c 100644 --- a/applications/MeshingApplication/custom_processes/nodal_values_interpolation_process.h +++ b/applications/MeshingApplication/custom_processes/nodal_values_interpolation_process.h @@ -116,7 +116,7 @@ class NodalValuesInterpolationProcess } } - virtual ~NodalValuesInterpolationProcess(){}; + ~NodalValuesInterpolationProcess() override= default;; ///@} ///@name Operators @@ -135,7 +135,7 @@ class NodalValuesInterpolationProcess * We execute the search relative to the old and new model part */ - virtual void Execute() + void Execute() override { // We create the locator BinBasedFastPointLocator PointLocator = BinBasedFastPointLocator(mrOriginMainModelPart); @@ -205,7 +205,7 @@ class NodalValuesInterpolationProcess /************************************ GET INFO *************************************/ /***********************************************************************************/ - virtual std::string Info() const + std::string Info() const override { return "NodalValuesInterpolationProcess"; } @@ -213,7 +213,7 @@ class NodalValuesInterpolationProcess /************************************ PRINT INFO ***********************************/ /***********************************************************************************/ - virtual void PrintInfo(std::ostream& rOStream) const + void PrintInfo(std::ostream& rOStream) const override { rOStream << Info(); } diff --git a/applications/MeshingApplication/custom_python/add_custom_strategies_to_python.cpp b/applications/MeshingApplication/custom_python/add_custom_strategies_to_python.cpp new file mode 100644 index 000000000000..be12412b2a80 --- /dev/null +++ b/applications/MeshingApplication/custom_python/add_custom_strategies_to_python.cpp @@ -0,0 +1,91 @@ +// KRATOS __ __ _____ ____ _ _ ___ _ _ ____ +// | \/ | ____/ ___|| | | |_ _| \ | |/ ___| +// | |\/| | _| \___ \| |_| || || \| | | _ +// | | | | |___ ___) | _ || || |\ | |_| | +// |_| |_|_____|____/|_| |_|___|_| \_|\____| APPLICATION +// +// License: BSD License +// license: MeshingApplication/license.txt +// +// Main authors: Vicente Mataix Ferrándiz +// + +// System includes + +// External includes +#include +#include +#include + +// Project includes +#include "includes/define.h" +#include "custom_python/add_custom_strategies_to_python.h" +#include "spaces/ublas_space.h" + +// Strategies + +// Schemes + +// Convergence criterias +#include "solving_strategies/convergencecriterias/convergence_criteria.h" +#include "custom_strategies/custom_convergencecriterias/error_mesh_criteria.h" + +// Builders and solvers + +// Linear solvers + +namespace Kratos +{ + +namespace Python +{ +using namespace boost::python; + +void AddCustomStrategiesToPython() +{ + typedef UblasSpace SparseSpaceType; + typedef UblasSpace LocalSpaceType; + + // Base types + typedef ConvergenceCriteria< SparseSpaceType, LocalSpaceType > ConvergenceCriteriaType; + + // Custom strategy types + + // Custom scheme types + + // Custom convergence criterion types + typedef ErrorMeshCriteria< SparseSpaceType, LocalSpaceType > ErrorMeshCriteriaType; + + // Custom builder and solvers types + + //******************************************************************** + //*************************STRATEGY CLASSES*************************** + //******************************************************************** + + //******************************************************************** + //*************************SCHEME CLASSES***************************** + //******************************************************************** + + //******************************************************************** + //*******************CONVERGENCE CRITERIA CLASSES********************* + //******************************************************************** + + // Displacement Convergence Criterion + class_< ErrorMeshCriteriaType, + bases< ConvergenceCriteriaType >, boost::noncopyable > + ( + "ErrorMeshCriteria", + init()) + .def("SetEchoLevel", &ErrorMeshCriteriaType::SetEchoLevel) + ; + + //******************************************************************** + //*************************BUILDER AND SOLVER************************* + //******************************************************************** + +} + +} // namespace Python. + +} // Namespace Kratos + diff --git a/applications/MeshingApplication/custom_python/add_custom_strategies_to_python.h b/applications/MeshingApplication/custom_python/add_custom_strategies_to_python.h new file mode 100644 index 000000000000..7ee7ca1d2517 --- /dev/null +++ b/applications/MeshingApplication/custom_python/add_custom_strategies_to_python.h @@ -0,0 +1,44 @@ +// KRATOS __ __ _____ ____ _ _ ___ _ _ ____ +// | \/ | ____/ ___|| | | |_ _| \ | |/ ___| +// | |\/| | _| \___ \| |_| || || \| | | _ +// | | | | |___ ___) | _ || || |\ | |_| | +// |_| |_|_____|____/|_| |_|___|_| \_|\____| APPLICATION +// +// License: BSD License +// license: MeshingApplication/license.txt +// +// Main authors: Vicente Mataix Ferrándiz +// + +#if !defined(KRATOS_STRATEGIES_PYTHON_H_INCLUDED ) +#define KRATOS_STRATEGIES_PYTHON_H_INCLUDED + + + +// System includes + + +// External includes +#include "boost/smart_ptr.hpp" + + +// Project includes +#include "includes/define.h" + + +namespace Kratos +{ + +namespace Python +{ + + void AddCustomStrategiesToPython(); + /* { */ + /* using namespace boost::python; */ + /* } */ + +} // namespace Python. + +} // namespace Kratos. + +#endif // KRATOS_STRATEGIES_PYTHON_H_INCLUDED defined diff --git a/applications/MeshingApplication/custom_python/add_custom_utilities_to_python.cpp b/applications/MeshingApplication/custom_python/add_custom_utilities_to_python.cpp index b517c992b886..457da6e28e03 100644 --- a/applications/MeshingApplication/custom_python/add_custom_utilities_to_python.cpp +++ b/applications/MeshingApplication/custom_python/add_custom_utilities_to_python.cpp @@ -36,10 +36,6 @@ #include "external_includes/pragmatic_adapt_3d.h" #endif -#ifdef INCLUDE_MMG - #include "custom_utilities/mmg_utility.h" -#endif - namespace Kratos { @@ -138,23 +134,6 @@ void AddCustomUtilitiesToPython() .def("AdaptMesh", &PragmaticAdaptor::AdaptMesh) ; #endif - -#ifdef INCLUDE_MMG - /* MMG UTILITY */ - // 2D - class_, boost::noncopyable > - ("MmgUtility2D", init()) - .def(init()) - .def("RemeshModelPart", &MmgUtility<2>::RemeshModelPart) - ; - - // 3D - class_, boost::noncopyable > - ("MmgUtility3D", init()) - .def(init()) - .def("RemeshModelPart", &MmgUtility<3>::RemeshModelPart) - ; -#endif class_("Cutting_Isosurface_Application", init< >()) .def("GenerateScalarVarCut", &Cutting_Isosurface_Application::GenerateVariableCut) diff --git a/applications/MeshingApplication/custom_python/add_processes_to_python.cpp b/applications/MeshingApplication/custom_python/add_processes_to_python.cpp index 05f5b5536935..7a97a70f74d9 100644 --- a/applications/MeshingApplication/custom_python/add_processes_to_python.cpp +++ b/applications/MeshingApplication/custom_python/add_processes_to_python.cpp @@ -23,13 +23,16 @@ #include "custom_processes/metric_fast_init_process.h" #include "custom_processes/metrics_levelset_process.h" #include "custom_processes/metrics_hessian_process.h" +#include "custom_processes/metrics_error_process.h" // #include "custom_processes/nodal_values_interpolation_process.h" #include "custom_processes/internal_variables_interpolation_process.h" // #include "custom_processes/set_h_map_process.h" //#include "custom_processes/find_nodal_h_process.h" // #include "custom_processes/embedded_mesh_locator_process.h" -#include "includes/node.h" +#ifdef INCLUDE_MMG + #include "custom_processes/mmg_process.h" +#endif namespace Kratos { @@ -69,49 +72,77 @@ void AddProcessesToPython() .def(init()) .def("Execute",&InternalVariablesInterpolationProcess::Execute) ; - + /* METRICS PROCESSES */ // Fast metric initializer - class_, bases >("MetricFastInit2D", init()) + class_, bases >("MetricFastInit2D", init()) .def("Execute",&MetricFastInit<2>::Execute) ; - class_, bases >("MetricFastInit3D", init()) + class_, bases >("MetricFastInit3D", init()) .def("Execute",&MetricFastInit<3>::Execute) ; // LEVEL SET - class_, bases >("ComputeLevelSetSolMetricProcess2D", init>>()) + class_, bases >("ComputeLevelSetSolMetricProcess2D", init>>()) .def(init>, Parameters>()) .def("Execute",&ComputeLevelSetSolMetricProcess<2>::Execute) ; - class_, bases >("ComputeLevelSetSolMetricProcess3D", init>>()) + class_, bases >("ComputeLevelSetSolMetricProcess3D", init>>()) .def(init>, Parameters>()) .def("Execute",&ComputeLevelSetSolMetricProcess<3>::Execute) ; // HESSIAN DOUBLE - class_>, bases >("ComputeHessianSolMetricProcess2D", init&>()) + class_>, bases >("ComputeHessianSolMetricProcess2D", init&>()) .def(init&, Parameters>()) .def("Execute",&ComputeHessianSolMetricProcess<2, Variable>::Execute) ; - class_>, bases >("ComputeHessianSolMetricProcess3D", init&>()) + class_>, bases >("ComputeHessianSolMetricProcess3D", init&>()) .def(init&, Parameters>()) .def("Execute",&ComputeHessianSolMetricProcess<3, Variable>::Execute) ; // HESSIAN ARRAY 1D - class_, bases >("ComputeHessianSolMetricProcessComp2D", init()) + class_, bases >("ComputeHessianSolMetricProcessComp2D", init()) .def(init()) .def("Execute",&ComputeHessianSolMetricProcess<2, component_type>::Execute) ; - - class_, bases >("ComputeHessianSolMetricProcessComp3D", init()) + + class_, bases >("ComputeHessianSolMetricProcessComp3D", init()) .def(init()) .def("Execute",&ComputeHessianSolMetricProcess<3, component_type>::Execute) ; + + // ERROR + class_, bases >("ComputeErrorSolMetricProcess2D", init()) + .def(init()) + .def("Execute",&ComputeErrorSolMetricProcess<2>::Execute) + ; + + class_, bases >("ComputeErrorSolMetricProcess3D", init()) + .def(init()) + .def("Execute",&ComputeErrorSolMetricProcess<3>::Execute) + ; + + /* MMG PROCESS */ + #ifdef INCLUDE_MMG + // 2D + class_, boost::noncopyable > + ("MmgProcess2D", init()) + .def(init()) + .def("Execute", &MmgProcess<2>::Execute) + ; + + // 3D + class_, boost::noncopyable > + ("MmgProcess3D", init()) + .def(init()) + .def("Execute", &MmgProcess<3>::Execute) + ; + #endif } } // namespace Python. diff --git a/applications/MeshingApplication/custom_python/kratos_meshing_python_application.cpp b/applications/MeshingApplication/custom_python/kratos_meshing_python_application.cpp index e0182a912972..a1724da38559 100644 --- a/applications/MeshingApplication/custom_python/kratos_meshing_python_application.cpp +++ b/applications/MeshingApplication/custom_python/kratos_meshing_python_application.cpp @@ -1,9 +1,16 @@ +// KRATOS __ __ _____ ____ _ _ ___ _ _ ____ +// | \/ | ____/ ___|| | | |_ _| \ | |/ ___| +// | |\/| | _| \___ \| |_| || || \| | | _ +// | | | | |___ ___) | _ || || |\ | |_| | +// |_| |_|_____|____/|_| |_|___|_| \_|\____| APPLICATION // -// Project Name: Kratos -// Last modified by: $Author: anonymous $ -// Date: $Date: 2008-11-05 17:07:44 $ -// Revision: $Revision: 1.4 $ +// License: BSD License +// Kratos default license: kratos/license.txt // +// Main authors: Nelson Lafontaine +// Jordi Cotela Dalmau +// Riccardo Rossi +// Vicente Mataix Ferrándiz // // System includes @@ -19,8 +26,7 @@ #include "custom_python/add_meshers_to_python.h" #include "custom_python/add_processes_to_python.h" #include "custom_python/add_custom_utilities_to_python.h" - - +#include "custom_python/add_custom_strategies_to_python.h" namespace Kratos { @@ -42,7 +48,9 @@ BOOST_PYTHON_MODULE(KratosMeshingApplication) AddMeshersToPython(); AddProcessesToPython(); AddCustomUtilitiesToPython(); + AddCustomStrategiesToPython(); + KRATOS_REGISTER_IN_PYTHON_VARIABLE(AVERAGE_NODAL_ERROR) KRATOS_REGISTER_IN_PYTHON_VARIABLE(ANISOTROPIC_RATIO) KRATOS_REGISTER_IN_PYTHON_VARIABLE(AUXILIAR_GRADIENT) KRATOS_REGISTER_IN_PYTHON_VARIABLE(AUXILIAR_HESSIAN) diff --git a/applications/MeshingApplication/custom_strategies/custom_convergencecriterias/error_mesh_criteria.h b/applications/MeshingApplication/custom_strategies/custom_convergencecriterias/error_mesh_criteria.h new file mode 100755 index 000000000000..adef3a33dfa0 --- /dev/null +++ b/applications/MeshingApplication/custom_strategies/custom_convergencecriterias/error_mesh_criteria.h @@ -0,0 +1,451 @@ +// KRATOS __ __ _____ ____ _ _ ___ _ _ ____ +// | \/ | ____/ ___|| | | |_ _| \ | |/ ___| +// | |\/| | _| \___ \| |_| || || \| | | _ +// | | | | |___ ___) | _ || || |\ | |_| | +// |_| |_|_____|____/|_| |_|___|_| \_|\____| APPLICATION +// +// License: BSD License +// license: MeshingApplication/license.txt +// +// Main authors: Vicente Mataix Ferrándiz +// + +#if !defined(KRATOS_ERROR_MESH_CRITERIA_H) +#define KRATOS_ERROR_MESH_CRITERIA_H + +/* System includes */ + +/* External includes */ + +/* Project includes */ +#include "includes/define.h" +#include "includes/model_part.h" +#include "meshing_application.h" +#include "includes/kratos_parameters.h" +#include "solving_strategies/convergencecriterias/convergence_criteria.h" +// Processes +#include "processes/find_nodal_h_process.h" +#include "custom_processes/metric_fast_init_process.h" +#include "custom_processes/metrics_error_process.h" +#ifdef INCLUDE_MMG + #include "custom_processes/mmg_process.h" +#endif + +namespace Kratos +{ +///@addtogroup MeshingApplication +///@{ + +///@name Kratos Globals +///@{ + +///@} +///@name Type Definitions +///@{ + +///@} +///@name Enum's +///@{ + + #if !defined(REMESHING_UTILITIES) + #define REMESHING_UTILITIES + enum RemeshingUtilities {MMG = 0}; + #endif + +///@} +///@name Functions +///@{ + +///@} +///@name Kratos Classes +///@{ + +/** @brief Custom convergence criteria for the mortar condition + */ +template +class ErrorMeshCriteria : public virtual ConvergenceCriteria< TSparseSpace, TDenseSpace > +{ +public: + ///@name Type Definitions + ///@{ + + KRATOS_CLASS_POINTER_DEFINITION( ErrorMeshCriteria ); + + typedef ConvergenceCriteria< TSparseSpace, TDenseSpace > BaseType; + + typedef TSparseSpace SparseSpaceType; + + typedef typename BaseType::TDataType TDataType; + + typedef typename BaseType::DofsArrayType DofsArrayType; + + typedef typename BaseType::TSystemMatrixType TSystemMatrixType; + + typedef typename BaseType::TSystemVectorType TSystemVectorType; + + typedef ModelPart::ConditionsContainerType ConditionsArrayType; + + typedef ModelPart::NodesContainerType NodesArrayType; + + typedef std::size_t KeyType; + + ///@} + ///@name Life Cycle + ///@{ + + /// Default constructors + ErrorMeshCriteria( + ModelPart& rThisModelPart, + Parameters ThisParameters = Parameters(R"({})") + ) + : ConvergenceCriteria< TSparseSpace, TDenseSpace >(), + mThisModelPart(rThisModelPart), + mDimension(rThisModelPart.GetProcessInfo()[DOMAIN_SIZE]), + mThisParameters(ThisParameters), + mFindNodalH(FindNodalHProcess(mThisModelPart)) + { + Parameters DefaultParameters = Parameters(R"( + { + "error_mesh_tolerance" : 1.0e-3, + "error_mesh_constant" : 1.0e-3, + "remeshing_utility" : "MMG", + "remeshing_parameters": + { + "filename" : "out", + "framework" : "Lagrangian", + "internal_variables_parameters" : + { + "allocation_size" : 1000, + "bucket_size" : 4, + "search_factor" : 2, + "interpolation_type" : "LST", + "internal_variable_interpolation_list" :[] + }, + "save_external_files" : false, + "max_number_of_searchs" : 1000, + "echo_level" : 3 + }, + "error_strategy_parameters": + { + "minimal_size" : 0.1, + "maximal_size" : 10.0, + "enforce_current" : true + } + })" ); + + mThisParameters.ValidateAndAssignDefaults(DefaultParameters); + + mErrorTolerance = mThisParameters["error_mesh_tolerance"].GetDouble(); + mConstantError = mThisParameters["error_mesh_constant"].GetDouble(); + mRemeshingUtilities = ConvertRemeshUtil(mThisParameters["remeshing_utility"].GetString()); + + #if !defined(INCLUDE_MMG) + if (mRemeshingUtilities == MMG) + { + KRATOS_ERROR << "YOU CAN USE MMG LIBRARY. CHECK YOUR COMPILATION" << std::endl; + } + #endif + } + + ///Copy constructor + ErrorMeshCriteria( ErrorMeshCriteria const& rOther ) + :BaseType(rOther) + ,mThisModelPart(rOther.mThisModelPart) + ,mDimension(rOther.mDimension) + ,mErrorTolerance(rOther.mErrorTolerance) + ,mConstantError(rOther.mConstantError) + { + } + + /// Destructor + ~ErrorMeshCriteria() override = default; + + ///@} + ///@name Operators + ///@{ + + /** + * Compute relative and absolute error. + * @param rModelPart Reference to the ModelPart containing the contact problem. + * @param rDofSet Reference to the container of the problem's degrees of freedom (stored by the BuilderAndSolver) + * @param A System matrix (unused) + * @param Dx Vector of results (variations on nodal variables) + * @param b RHS vector (residual) + * @return true if convergence is achieved, false otherwise + */ + + bool PostCriteria( + ModelPart& rModelPart, + DofsArrayType& rDofSet, + const TSystemMatrixType& A, + const TSystemVectorType& Dx, + const TSystemVectorType& b + ) override + { + // We recompute the NODAL_H + mFindNodalH.Execute(); + + // We initialize the check + bool ConvergedError = true; + + // We initialize the total error + double TotalErrorPow2 = 0.0; + double CurrentSolPow2 = 0.0; + + // Iterate in the nodes + NodesArrayType& NodesArray = rModelPart.Nodes(); + int numNodes = NodesArray.end() - NodesArray.begin(); + +// #pragma omp parallel for // FIXME: Parallel not working + for(int i = 0; i < numNodes; i++) + { + auto itNode = NodesArray.begin() + i; + + double MainDoFNodalError = 0.0; + double OtherDoFNodalError = 0.0; + + Node<3>::DofsContainerType& NodeDofs = (itNode)->GetDofs(); + + std::size_t DoFId; +// TDataType DofValue; + + for (typename Node<3>::DofsContainerType::const_iterator itDof = NodeDofs.begin(); itDof != NodeDofs.end(); itDof++) + { + if (itDof->IsFree()) + { + DoFId = itDof->EquationId(); +// DofValue = itDof->GetSolutionStepValue(0); + + KeyType CurrVar = itDof->GetVariable().Key(); + if ((CurrVar == DISPLACEMENT_X) || (CurrVar == DISPLACEMENT_Y) || (CurrVar == DISPLACEMENT_Z) || (CurrVar == VELOCITY_X) || (CurrVar == VELOCITY_Y) || (CurrVar == VELOCITY_Z)) + { + MainDoFNodalError += b[DoFId] * b[DoFId]; + } + else + { + OtherDoFNodalError += b[DoFId] * b[DoFId]; + } + } +// else +// { +// // const double Reaction = itDof->GetSolutionStepReactionValue(); +// // // #pragma omp atomic +// // CurrentSolPow2 += Reaction * Reaction; +// +// DoFId = itDof->EquationId(); +// +// // #pragma omp atomic +// CurrentSolPow2 += b[DoFId] * b[DoFId]; +// } + } + + const double NodalH = itNode->FastGetSolutionStepValue(NODAL_H); + + const double NodalError = NodalH * NodalH * std::sqrt(MainDoFNodalError) + NodalH * std::sqrt(OtherDoFNodalError); + itNode->SetValue(NODAL_ERROR, NodalError); + +// #pragma omp atomic + TotalErrorPow2 += (NodalError * NodalError); + } + + // Setting the average nodal error + rModelPart.GetProcessInfo()[AVERAGE_NODAL_ERROR] = mErrorTolerance * std::sqrt((CurrentSolPow2 + TotalErrorPow2)/numNodes); + +// // Debug +// KRATOS_WATCH(CurrentSolPow2) +// KRATOS_WATCH(TotalErrorPow2) + + // Final check + const double MeshError = mConstantError * std::sqrt(TotalErrorPow2); +// const double MeshError = std::sqrt(TotalErrorPow2/(CurrentSolPow2 + TotalErrorPow2)); + if (MeshError > mErrorTolerance) + { + ConvergedError = false; + } + + if (ConvergedError == true) + { + if (rModelPart.GetCommunicator().MyPID() == 0 && this->GetEchoLevel() > 0) + { + std::cout << "The error due to the mesh size: " << MeshError << " is under the tolerance prescribed: " << mErrorTolerance << ". No remeshing required" << std::endl; + } + } + else + { + if (rModelPart.GetCommunicator().MyPID() == 0 && this->GetEchoLevel() > 0) + { + std::cout << "The error due to the mesh size: " << MeshError << " is bigger than the tolerance prescribed: " << mErrorTolerance << ". Remeshing required" << std::endl; + std::cout << "AVERAGE_NODAL_ERROR: " << rModelPart.GetProcessInfo()[AVERAGE_NODAL_ERROR] << std::endl; + } + + // Computing metric + if (mDimension == 2) + { + MetricFastInit<2> MetricInit = MetricFastInit<2>(mThisModelPart); + MetricInit.Execute(); + ComputeErrorSolMetricProcess<2> ComputeMetric = ComputeErrorSolMetricProcess<2>(mThisModelPart, mThisParameters["error_strategy_parameters"]); + ComputeMetric.Execute(); + } + else + { + MetricFastInit<3> MetricInit = MetricFastInit<3>(mThisModelPart); + MetricInit.Execute(); + ComputeErrorSolMetricProcess<3> ComputeMetric = ComputeErrorSolMetricProcess<3>(mThisModelPart, mThisParameters["error_strategy_parameters"]); + ComputeMetric.Execute(); + } + + // Remeshing + if (mRemeshingUtilities == MMG) + { + #ifdef INCLUDE_MMG + if (mDimension == 2) + { + MmgProcess<2> MmgRemesh = MmgProcess<2>(mThisModelPart, mThisParameters["remeshing_parameters"]); + MmgRemesh.Execute(); + } + else + { + MmgProcess<3> MmgRemesh = MmgProcess<3>(mThisModelPart, mThisParameters["remeshing_parameters"]); + MmgRemesh.Execute(); + } + #else + KRATOS_ERROR << "Please compile with MMG to use this utility" << std::endl; + #endif + } + else + { + KRATOS_ERROR << "Not an alternative utility" << std::endl; + } + + mFindNodalH.Execute(); + } + + return ConvergedError; + } + + /** + * This function initialize the convergence criteria + * @param rModelPart: The model part of interest + */ + + void Initialize(ModelPart& rModelPart) override + { + BaseType::mConvergenceCriteriaIsInitialized = true; + } + + ///@} + ///@name Operations + ///@{ + + ///@} + ///@name Acces + ///@{ + + ///@} + ///@name Inquiry + ///@{ + + ///@} + ///@name Friends + ///@{ + +protected: + + ///@name Protected static Member Variables + ///@{ + + ///@} + ///@name Protected member Variables + ///@{ + + ///@} + ///@name Protected Operators + ///@{ + + /** + * This converts the remehing utility string to an enum + * @param str: The string that you want to comvert in the equivalent enum + * @return RemeshingUtilities: The equivalent enum (this requires less memmory than a std::string) + */ + + RemeshingUtilities ConvertRemeshUtil(const std::string& str) + { + if(str == "MMG") + { + return MMG; + } + else + { + return MMG; + } + } + + ///@} + ///@name Protected Operations + ///@{ + + ///@} + ///@name Protected Access + ///@{ + + ///@} + ///@name Protected Inquiry + ///@{ + + ///@} + ///@name Protected LifeCycle + ///@{ + ///@} + +private: + ///@name Static Member Variables + ///@{ + + ///@} + ///@name Member Variables + ///@{ + + ModelPart& mThisModelPart; // The model part where the refinement is computed + const unsigned int mDimension; // The dimension of the problem + Parameters mThisParameters; // The parameters + + FindNodalHProcess mFindNodalH; // The process to copmpute NODAL_H + RemeshingUtilities mRemeshingUtilities; // The remeshing utilities to use + + double mErrorTolerance; // The error tolerance considered + double mConstantError; // The constant considered in the remeshing process + + ///@} + ///@name Private Operators + ///@{ + + ///@} + ///@name Private Operations + ///@{ + + ///@} + ///@name Private Access + ///@{ + ///@} + + ///@} + ///@name Serialization + ///@{ + + ///@name Private Inquiry + ///@{ + ///@} + + ///@name Unaccessible methods + ///@{ + ///@} + +}; // Class ErrorMeshCriteria + +///@name Explicit Specializations +///@{ + +} // namespace Kratos + +#endif /* KRATOS_ERROR_MESH_CRITERIA_H defined */ + diff --git a/applications/MeshingApplication/custom_utilities/binbased_projection.h b/applications/MeshingApplication/custom_utilities/binbased_projection.h index 0d27dcfc0181..13ebef04745c 100644 --- a/applications/MeshingApplication/custom_utilities/binbased_projection.h +++ b/applications/MeshingApplication/custom_utilities/binbased_projection.h @@ -91,10 +91,10 @@ class BinBasedMeshTransfer ///@{ /// Default constructor. - BinBasedMeshTransfer() {} // + BinBasedMeshTransfer() = default; // /// Destructor. - virtual ~BinBasedMeshTransfer() {} + virtual ~BinBasedMeshTransfer() = default; ///@} @@ -171,7 +171,7 @@ class BinBasedMeshTransfer { ModelPart::NodesContainerType::iterator iparticle = rMoving_ModelPart.NodesBegin() + i; Node < 3 > ::Pointer pparticle = *(iparticle.base()); - typename BinBasedFastPointLocator::ResultIteratorType result_begin = results.begin(); + auto result_begin = results.begin(); Element::Pointer pelement; bool is_found = node_locator.FindPointOnMesh(pparticle->Coordinates(), N, pelement, result_begin, max_results); @@ -249,7 +249,7 @@ class BinBasedMeshTransfer ModelPart::NodesContainerType::iterator iparticle = rMoving_ModelPart.NodesBegin() + i; Node < 3 > ::Pointer pparticle = *(iparticle.base()); - typename BinBasedFastPointLocator::ResultIteratorType result_begin = results.begin(); + auto result_begin = results.begin(); Element::Pointer pelement; @@ -341,7 +341,7 @@ class BinBasedMeshTransfer unsigned int nfound = node_locator.FindNodesInElement(*(elem_it.base()), positions, Nmat, max_results, work_results.begin(), work_distances.begin(), work_point); for(unsigned int k=0; k N = row(Nmat,k); diff --git a/applications/MeshingApplication/custom_utilities/cutting_iso_app.h b/applications/MeshingApplication/custom_utilities/cutting_iso_app.h index 71be1ccdc640..4fd7ca0efa57 100644 --- a/applications/MeshingApplication/custom_utilities/cutting_iso_app.h +++ b/applications/MeshingApplication/custom_utilities/cutting_iso_app.h @@ -85,10 +85,10 @@ class Cutting_Isosurface_Application ///@{ /// Default constructor. - Cutting_Isosurface_Application() {} + Cutting_Isosurface_Application() = default; /// Destructor. - virtual ~Cutting_Isosurface_Application() {} + virtual ~Cutting_Isosurface_Application() = default; ///This function Creates cutting isosurfaces by creating nodes and conditions (to define the conectivities) in a different model part. (new_model_part) diff --git a/applications/MeshingApplication/custom_utilities/local_refine_geometry_mesh.cpp b/applications/MeshingApplication/custom_utilities/local_refine_geometry_mesh.cpp index 24f10dfc3d2e..3d562b48a02e 100644 --- a/applications/MeshingApplication/custom_utilities/local_refine_geometry_mesh.cpp +++ b/applications/MeshingApplication/custom_utilities/local_refine_geometry_mesh.cpp @@ -345,8 +345,8 @@ namespace Kratos this_model_part.Nodes().clear(); this_model_part.Nodes().reserve(aux_node_list.size()); - for(auto it = aux_node_list.begin(); it!=aux_node_list.end(); it++) - this_model_part.Nodes().push_back(it->second); + for(auto & it : aux_node_list) + this_model_part.Nodes().push_back(it.second); this_model_part.Nodes().Sort(); @@ -486,7 +486,7 @@ namespace Kratos for (ModelPart::SubModelPartIterator iSubModelPart = rModelPart.SubModelPartsBegin(); iSubModelPart != rModelPart.SubModelPartsEnd(); iSubModelPart++) { - for (ModelPart::NodesContainerType::ptr_iterator iNode = rModelPart.Nodes().ptr_begin(); + for (auto iNode = rModelPart.Nodes().ptr_begin(); iNode != rModelPart.Nodes().ptr_end(); iNode++) { WeakPointerVector< Node<3> > &rFatherNodes = (*iNode)->GetValue(FATHER_NODES); diff --git a/applications/MeshingApplication/custom_utilities/local_refine_geometry_mesh.hpp b/applications/MeshingApplication/custom_utilities/local_refine_geometry_mesh.hpp index 1071a55cd9d6..c92451c55529 100644 --- a/applications/MeshingApplication/custom_utilities/local_refine_geometry_mesh.hpp +++ b/applications/MeshingApplication/custom_utilities/local_refine_geometry_mesh.hpp @@ -90,9 +90,7 @@ class LocalRefineGeometryMesh /// Destructor ~LocalRefineGeometryMesh() - { - - } + = default; ///@} ///@name Operators diff --git a/applications/MeshingApplication/custom_utilities/local_refine_prism_mesh.hpp b/applications/MeshingApplication/custom_utilities/local_refine_prism_mesh.hpp index 953a19d4d7dd..61c860fd2bd7 100644 --- a/applications/MeshingApplication/custom_utilities/local_refine_prism_mesh.hpp +++ b/applications/MeshingApplication/custom_utilities/local_refine_prism_mesh.hpp @@ -61,9 +61,7 @@ class LocalRefinePrismMesh : public LocalRefineGeometryMesh /// Destructor ~LocalRefinePrismMesh() - { - - } + = default; ///@} ///@name Operators @@ -182,7 +180,7 @@ class LocalRefinePrismMesh : public LocalRefineGeometryMesh const compressed_matrix& Coord, PointerVector< Element >& New_Elements, bool interpolate_internal_variables - ) + ) override { ElementsArrayType& rElements = this_model_part.Elements(); ElementsArrayType::iterator it_begin = rElements.ptr_begin(); @@ -205,9 +203,9 @@ class LocalRefinePrismMesh : public LocalRefineGeometryMesh unsigned int current_id = (rElements.end() - 1)->Id() + 1; for (ElementsArrayType::iterator it = it_begin; it != it_end; ++it) { - for (unsigned int i = 0; i < 24; i++) + for (int & i : t) { - t[i] = -1; + i = -1; } Element::GeometryType& geom = it->GetGeometry(); @@ -290,7 +288,7 @@ class LocalRefinePrismMesh : public LocalRefineGeometryMesh void EraseOldConditionsAndCreateNew( ModelPart& this_model_part, const compressed_matrix& Coord - ) + ) override { KRATOS_TRY; @@ -404,7 +402,7 @@ class LocalRefinePrismMesh : public LocalRefineGeometryMesh const compressed_matrix& Coord, int* edge_ids, std::vector & aux - ) + ) override { aux.resize(12, false); diff --git a/applications/MeshingApplication/custom_utilities/local_refine_sprism_mesh.hpp b/applications/MeshingApplication/custom_utilities/local_refine_sprism_mesh.hpp index a00bc92f19cb..bbdc2fb8523b 100644 --- a/applications/MeshingApplication/custom_utilities/local_refine_sprism_mesh.hpp +++ b/applications/MeshingApplication/custom_utilities/local_refine_sprism_mesh.hpp @@ -62,9 +62,7 @@ class LocalRefineSPrismMesh : public LocalRefineGeometryMesh /// Destructor ~LocalRefineSPrismMesh() - { - - } + = default; ///@} ///@name Operators @@ -183,7 +181,7 @@ class LocalRefineSPrismMesh : public LocalRefineGeometryMesh const compressed_matrix& Coord, PointerVector< Element >& New_Elements, bool interpolate_internal_variables - ) + ) override { ElementsArrayType& rElements = this_model_part.Elements(); ElementsArrayType::iterator it_begin = rElements.ptr_begin(); @@ -206,9 +204,9 @@ class LocalRefineSPrismMesh : public LocalRefineGeometryMesh unsigned int current_id = (rElements.end() - 1)->Id() + 1; for (ElementsArrayType::iterator it = it_begin; it != it_end; ++it) { - for (unsigned int i = 0; i < 24; i++) + for (int & i : t) { - t[i] = -1; + i = -1; } Element::GeometryType& geom = it->GetGeometry(); @@ -302,7 +300,7 @@ class LocalRefineSPrismMesh : public LocalRefineGeometryMesh void EraseOldConditionsAndCreateNew( ModelPart& this_model_part, const compressed_matrix& Coord - ) + ) override { KRATOS_TRY; @@ -416,7 +414,7 @@ class LocalRefineSPrismMesh : public LocalRefineGeometryMesh const compressed_matrix& Coord, int* edge_ids, std::vector & aux - ) + ) override { aux.resize(12, false); diff --git a/applications/MeshingApplication/custom_utilities/local_refine_tetrahedra_mesh.hpp b/applications/MeshingApplication/custom_utilities/local_refine_tetrahedra_mesh.hpp index 6c06800ebcce..fb14819163d1 100644 --- a/applications/MeshingApplication/custom_utilities/local_refine_tetrahedra_mesh.hpp +++ b/applications/MeshingApplication/custom_utilities/local_refine_tetrahedra_mesh.hpp @@ -64,9 +64,7 @@ class LocalRefineTetrahedraMesh : public LocalRefineGeometryMesh /// Destructor ~LocalRefineTetrahedraMesh() - { - - } + = default; ///@} ///@name Operators @@ -165,7 +163,7 @@ class LocalRefineTetrahedraMesh : public LocalRefineGeometryMesh const compressed_matrix& Coord, PointerVector< Element >& NewElements, bool interpolate_internal_variables - ) + ) override { ElementsArrayType& rElements = this_model_part.Elements(); ElementsArrayType::iterator it_begin = rElements.ptr_begin(); @@ -186,9 +184,9 @@ class LocalRefineTetrahedraMesh : public LocalRefineGeometryMesh std::cout << "****************** REFINING MESH ******************" << std::endl; std::cout << "OLD NUMBER ELEMENTS: " << rElements.size() << std::endl; - for (unsigned int i = 0; i < 56; i++) + for (int & i : t) { - t[i] = -1; + i = -1; } for (ElementsArrayType::iterator it = it_begin; it != it_end; ++it) @@ -318,7 +316,7 @@ class LocalRefineTetrahedraMesh : public LocalRefineGeometryMesh to_be_deleted++; WeakPointerVector< Element >& rChildElements = iElem->GetValue(NEIGHBOUR_ELEMENTS); - for ( WeakPointerVector< Element >::ptr_iterator iChild = rChildElements.ptr_begin(); + for ( auto iChild = rChildElements.ptr_begin(); iChild != rChildElements.ptr_end(); iChild++ ) { NewElements.push_back( (*iChild).lock() ); @@ -358,7 +356,7 @@ class LocalRefineTetrahedraMesh : public LocalRefineGeometryMesh void EraseOldConditionsAndCreateNew( ModelPart& this_model_part, const compressed_matrix& Coord - ) + ) override { KRATOS_TRY; @@ -447,7 +445,7 @@ class LocalRefineTetrahedraMesh : public LocalRefineGeometryMesh this_model_part.Conditions().reserve(total_size); /// Add the new Conditions to the ModelPart - for (PointerVector< Condition >::ptr_iterator iCond = NewConditions.ptr_begin(); + for (auto iCond = NewConditions.ptr_begin(); iCond != NewConditions.ptr_end(); iCond++) { this_model_part.Conditions().push_back( *iCond ); @@ -480,7 +478,7 @@ class LocalRefineTetrahedraMesh : public LocalRefineGeometryMesh to_be_deleted++; WeakPointerVector< Condition >& rChildConditions = iCond->GetValue(NEIGHBOUR_CONDITIONS); - for ( WeakPointerVector< Condition >::ptr_iterator iChild = rChildConditions.ptr_begin(); + for ( auto iChild = rChildConditions.ptr_begin(); iChild != rChildConditions.ptr_end(); iChild++ ) { NewConditions.push_back( (*iChild).lock() ); @@ -527,7 +525,7 @@ class LocalRefineTetrahedraMesh : public LocalRefineGeometryMesh const compressed_matrix& Coord, int* edge_ids, std::vector & aux - ) + ) override { aux.resize(11, false); diff --git a/applications/MeshingApplication/custom_utilities/local_refine_triangle_mesh.hpp b/applications/MeshingApplication/custom_utilities/local_refine_triangle_mesh.hpp index f92f4c269278..901ff6942730 100644 --- a/applications/MeshingApplication/custom_utilities/local_refine_triangle_mesh.hpp +++ b/applications/MeshingApplication/custom_utilities/local_refine_triangle_mesh.hpp @@ -66,9 +66,7 @@ class LocalRefineTriangleMesh : public LocalRefineGeometryMesh /// Destructor ~LocalRefineTriangleMesh() - { - - } + = default; ///@} ///@name Operators @@ -167,7 +165,7 @@ class LocalRefineTriangleMesh : public LocalRefineGeometryMesh const compressed_matrix& Coord, PointerVector< Element >& New_Elements, bool interpolate_internal_variables - ) + ) override { ElementsArrayType& rElements = this_model_part.Elements(); ElementsArrayType::iterator it_begin = rElements.ptr_begin(); @@ -193,9 +191,9 @@ class LocalRefineTriangleMesh : public LocalRefineGeometryMesh unsigned int current_id = (rElements.end() - 1)->Id() + 1; for (ElementsArrayType::iterator it = it_begin; it != it_end; ++it) { - for (unsigned int i = 0; i < 12; i++) + for (int & i : t) { - t[i] = -1; + i = -1; } Element::GeometryType& geom = it->GetGeometry(); CalculateEdges(geom, Coord, edge_ids, aux); @@ -303,7 +301,7 @@ class LocalRefineTriangleMesh : public LocalRefineGeometryMesh void EraseOldConditionsAndCreateNew( ModelPart& this_model_part, const compressed_matrix& Coord - ) + ) override { KRATOS_TRY; @@ -442,7 +440,7 @@ class LocalRefineTriangleMesh : public LocalRefineGeometryMesh const compressed_matrix& Coord, int* edge_ids, std::vector & aux - ) + ) override { aux.resize(6, false); diff --git a/applications/MeshingApplication/custom_utilities/mmg_utility.h b/applications/MeshingApplication/custom_utilities/mmg_utility.h deleted file mode 100644 index 6617fdbea400..000000000000 --- a/applications/MeshingApplication/custom_utilities/mmg_utility.h +++ /dev/null @@ -1,2939 +0,0 @@ -// KRATOS __ __ _____ ____ _ _ ___ _ _ ____ -// | \/ | ____/ ___|| | | |_ _| \ | |/ ___| -// | |\/| | _| \___ \| |_| || || \| | | _ -// | | | | |___ ___) | _ || || |\ | |_| | -// |_| |_|_____|____/|_| |_|___|_| \_|\____| APPLICATION -// -// License: BSD License -// license: MeshingApplication/license.txt -// -// Main authors: Vicente Mataix Ferrándiz -// - -#if !defined(KRATOS_MMG_UTILITY) -#define KRATOS_MMG_UTILITY - -// Project includes -#include "utilities/math_utils.h" -#include "includes/model_part.h" -#include "includes/kratos_parameters.h" -#include "containers/variables_list.h" -#include "utilities/openmp_utils.h" -#include "input_output/logger.h" -#include -#include -// The includes related with the MMG library -#include "mmg/libmmg.h" -#include "mmg/mmg2d/libmmg2d.h" -#include "mmg/mmg3d/libmmg3d.h" -#include "mmg/mmgs/libmmgs.h" -// We indlude the internal variable interpolation process -#include "custom_processes/nodal_values_interpolation_process.h" -#include "custom_processes/internal_variables_interpolation_process.h" -// Include the point locator -#include "utilities/binbased_fast_point_locator.h" -// Include the spatial containers needed for search -#include "spatial_containers/spatial_containers.h" // kd-tree - -// NOTE: The following contains the license of the MMG library -/* ============================================================================= -** Copyright (c) Bx INP/Inria/UBordeaux/UPMC, 2004- . -** -** mmg is free software: you can redistribute it and/or modify it -** under the terms of the GNU Lesser General Public License as published -** by the Free Software Foundation, either version 3 of the License, or -** (at your option) any later version. -** -** mmg is distributed in the hope that it will be useful, but WITHOUT -** ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or -** FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public -** License for more details. -** -** You should have received a copy of the GNU Lesser General Public -** License and of the GNU General Public License along with mmg (in -** files COPYING.LESSER and COPYING). If not, see -** . Please read their terms carefully and -** use this copy of the mmg distribution only if you accept them. -** ============================================================================= -*/ - -namespace Kratos -{ -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - // Containers definition - typedef ModelPart::NodesContainerType NodesArrayType; - typedef ModelPart::ElementsContainerType ElementsArrayType; - typedef ModelPart::ConditionsContainerType ConditionsArrayType; - - // Components definition - typedef Node <3> NodeType; - typedef Properties PropertiesType; - typedef Element ElementType; - typedef Condition ConditionType; - - // Index defintion - typedef std::size_t IndexType; - typedef std::size_t SizeType; - - // DoF definition - typedef Dof DofType; - - // Mesh definition - typedef Mesh MeshType; - typedef MeshType::PropertiesContainerType PropertiesContainerType; - typedef MeshType::NodeConstantIterator NodeConstantIterator; - typedef MeshType::ConditionConstantIterator ConditionConstantIterator; - typedef MeshType::ElementConstantIterator ElementConstantIterator; - - #if !defined(KEY_COMPAROR_VECTOR) - #define KEY_COMPAROR_VECTOR - template - struct KeyComparorVector - { - bool operator()(const vector& lhs, const vector& rhs) const - { - if(lhs.size() != rhs.size()) - { - return false; - } - - for(unsigned int i=0; i - struct KeyHasherVector - { - std::size_t operator()(const vector& k) const - { - return boost::hash_range(k.begin(), k.end()); - } - }; - #endif - -///@} -///@name Enum's -///@{ - - /** - * This enums are used to simplify the computation of the std::vector containing the conditions and elements - */ - - enum CondGeometries2D {Line = 0}; - - enum ElemGeometries2D {Triangle2D = 0}; - - enum CondGeometries3D {Triangle3D = 0, Quadrilateral3D = 1}; - - enum ElemGeometries3D {Tetrahedra = 0, Prism = 1}; - - #if !defined(FRAMEWORK_EULER_LAGRANGE) - #define FRAMEWORK_EULER_LAGRANGE - enum FrameworkEulerLagrange {Eulerian = 0, Lagrangian = 1}; - #endif - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -//// This class is a remesher which uses the MMG library -// The class uses a class for the 2D and 3D cases - -template -class MmgUtility -{ -public: - - ///@name Type Definitions - ///@{ - - ///@} - ///@name Life Cycle - ///@{ - - // Constructor - - /** - * This is the default constructor, which is used to read the input files - * @param rThisModelPart: The model part - * @param ThisParameters: The parameters - */ - - MmgUtility( - ModelPart& rThisModelPart, - Parameters ThisParameters = Parameters(R"({})") - ) - :mrThisModelPart(rThisModelPart), - mThisParameters(ThisParameters) - { - Parameters DefaultParameters = Parameters(R"( - { - "mesh_id" : 0, - "filename" : "out", - "model_part_name" : "MainModelPart", - "strategy" : "LevelSet", - "level_set_strategy_parameters" :{ - "scalar_variable" : "DISTANCE", - "gradient_variable" : "DISTANCE_GRADIENT" - }, - "framework" : "Eulerian", - "internal_variables_parameters" : - { - "allocation_size" : 1000, - "bucket_size" : 4, - "search_factor" : 2, - "interpolation_type" : "LST", - "internal_variable_interpolation_list" :[] - }, - "hessian_strategy_parameters" :{ - "metric_variable" : ["DISTANCE"], - "interpolation_error" : 0.04, - "mesh_dependent_constant" : 0.0 - }, - "enforce_current" : true, - "initial_step" : 1, - "step_frequency" : 0, - "automatic_remesh" : true, - "automatic_remesh_parameters" :{ - "automatic_remesh_type" : "Ratio", - "min_size_ratio" : 1.0, - "max_size_ratio" : 3.0, - "refer_type" : "Mean", - "min_size_current_percentage" : 50.0, - "max_size_current_percentage" : 98.0 - }, - "initial_remeshing" : true, - "fix_contour_model_parts" : [], - "minimal_size" : 0.1, - "maximal_size" : 10.0, - "anisotropy_remeshing" : true, - "anisotropy_parameters":{ - "hmin_over_hmax_anisotropic_ratio" : 0.01, - "boundary_layer_max_distance" : 1.0, - "boundary_layer_min_size_ratio" : 2.0, - "interpolation" : "Linear" - }, - "save_external_files" : false, - "max_number_of_searchs" : 1000, - "echo_level" : 3, - "step_data_size" : 0, - "buffer_size" : 0 - })" ); - - mThisParameters.ValidateAndAssignDefaults(DefaultParameters); - - mStdStringFilename = mThisParameters["filename"].GetString(); - mEchoLevel = mThisParameters["echo_level"].GetInt(); - - mFilename = new char [mStdStringFilename.length() + 1]; - std::strcpy (mFilename, mStdStringFilename.c_str()); - - mFramework = ConvertFramework(mThisParameters["framework"].GetString()); - - mpRefElement.resize(TDim - 1); - mpRefCondition.resize(TDim - 1); - mInitRefCondition.resize(TDim - 1); - mInitRefElement.resize(TDim - 1); - for (unsigned int i_dim = 0; i_dim < TDim - 1; i_dim++) - { - mpRefElement[i_dim] = nullptr; - mInitRefCondition[i_dim] = false; - mpRefCondition[i_dim] = nullptr; - mInitRefElement[i_dim] = false; - } - } - - /// Destructor. - ~MmgUtility() {} - - ///@} - ///@name Operators - ///@{ - - - ///@} - ///@name Operations - ///@{ - - /** - * Instead of using an files already created we read an existing model part - */ - - void RemeshModelPart() - { - const bool SaveToFile = mThisParameters["save_external_files"].GetBool(); - - /* We restart the MMG mesh and solution */ - InitMesh(); - - /* We print the original model part */ - if (mEchoLevel > 0) - { - std::cout << "//---------------------------------------------------//" << std::endl; - std::cout << "//---------------------------------------------------//" << std::endl; - std::cout << "//--------------- BEFORE REMESHING ---------------//" << std::endl; - std::cout << "//---------------------------------------------------//" << std::endl; - std::cout << "//---------------------------------------------------//" << std::endl << std::endl; - - KRATOS_WATCH(mrThisModelPart); - } - - // We initialize the mesh and solution data - InitializeMeshData(); - InitializeSolData(); - - // Check if the number of given entities match with mesh size - CheckMeshData(); - - // Save to file - if (SaveToFile == true) - { - SaveSolutionToFile(false); - } - - // We execute the remeshing - ExecuteRemeshing(); - - /* We print the resulting model part */ - if (mEchoLevel > 0) - { - std::cout << "//---------------------------------------------------//" << std::endl; - std::cout << "//---------------------------------------------------//" << std::endl; - std::cout << "//--------------- AFTER REMESHING ---------------//" << std::endl; - std::cout << "//---------------------------------------------------//" << std::endl; - std::cout << "//---------------------------------------------------//" << std::endl << std::endl; - - KRATOS_WATCH(mrThisModelPart); - } - } - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - -protected: - ///@name Protected static Member Variables - ///@{ - - ///@} - ///@name Protected member Variables - ///@{ - - // The model part to compute - ModelPart& mrThisModelPart; - - // The parameters (can be used for general pourposes) - Parameters mThisParameters; - - // Storage for the dof of the node - Node<3>::DofsContainerType mDofs; - - // I/O information - char* mFilename; - std::string mStdStringFilename; - unsigned int mEchoLevel; - - // The framework - FrameworkEulerLagrange mFramework; - - // The member variables related with the MMG library - MMG5_pMesh mmgMesh; - MMG5_pSol mmgSol; - - // Where the sub model parts IDs are stored - boost::unordered_map> mColors; - - // Reference element and condition - std::vector mpRefElement; - std::vector mpRefCondition; - std::vector mInitRefElement; - std::vector mInitRefCondition; - - ///@} - ///@name Protected Operators - ///@{ - - ///@} - ///@name Protected Operations - ///@{ - - /** - * This function generates the mesh MMG5 structure from a Kratos Model Part - */ - - void InitializeMeshData() - { - // First we compute the colors - boost::unordered_map NodeColors, CondColors, ElemColors; - ComputeColors(NodeColors, CondColors, ElemColors); - - /////////* MESH FILE *///////// - // Build mesh in MMG5 format // - - // Iterate in the nodes - NodesArrayType& pNode = mrThisModelPart.Nodes(); - auto numNodes = pNode.end() - pNode.begin(); - - // Iterate in the conditions - ConditionsArrayType& pConditions = mrThisModelPart.Conditions(); - auto numConditions = pConditions.end() - pConditions.begin(); - - // Iterate in the elements - ElementsArrayType& pElements = mrThisModelPart.Elements(); - auto numElements = pElements.end() - pElements.begin(); - - /* Manually set of the mesh */ - array_1d numArrayElements; - array_1d numArrayConditions; - if (TDim == 2) - { - numArrayConditions[0] = numConditions; - numArrayElements[0] = numElements; - } - else - { - // We initialize the values - numArrayElements[0] = 0; // Tetrahedron - numArrayElements[1] = 0; // Prisms - - numArrayConditions[0] = 0; // Triangles - numArrayConditions[1] = 0; // Quadrilaterals - - /* Elements */ - for(unsigned int i = 0; i < numElements; i++) - { - auto itElem = pElements.begin() + i; - - if ((itElem->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Tetrahedra3D4) // Tetrahedron - { - numArrayElements[0] += 1; - } - else if ((itElem->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Prism3D6) // Prisms - { - numArrayElements[1] += 1; - } - else - { - std::cout << "WARNING: YOUR GEOMETRY CONTAINS HEXAEDRON THAT CAN NOT BE REMESHED" << std::endl; - } - } - - if (((numArrayElements[0] + numArrayElements[1]) < numElements) && mEchoLevel > 0) - { - std::cout << "Number of Elements: " << numElements << " Number of Tetrahedron: " << numArrayElements[0] << " Number of Prisms: " << numArrayElements[1] << std::endl; - } - - /* Conditions */ - for(unsigned int i = 0; i < numConditions; i++) - { - auto itCond = pConditions.begin() + i; - - if ((itCond->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Triangle3D3) // Triangles - { - numArrayConditions[0] += 1; - } - else if ((itCond->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Quadrilateral3D4) // Quadrilaterals - { - numArrayConditions[1] += 1; - } - } - } - - SetMeshSize(numNodes, numArrayElements, numArrayConditions); - - /* Nodes */ - // We copy the DOF from the fisrt node (after we release, to avoid problem with previous conditions) - mDofs = pNode.begin()->GetDofs(); - for (typename Node<3>::DofsContainerType::const_iterator itDoF = mDofs.begin(); itDoF != mDofs.end(); itDoF++) - { - itDoF->FreeDof(); - } - -// #pragma omp parallel for - for(unsigned int i = 0; i < numNodes; i++) - { - auto itNode = pNode.begin() + i; - - SetNodes(itNode->X(), itNode->Y(), itNode->Z(), NodeColors[itNode->Id()], i + 1); - - bool blocked = false; - if (itNode->IsDefined(BLOCKED) == true) - { - blocked = itNode->Is(BLOCKED); - } - if (TDim == 3 && blocked == true) - { - BlockNode(i + 1); - } - - // RESETING THE ID OF THE NODES (important for non consecutive meshes) - itNode->SetId(i + 1); - } - - /* Conditions */ - // We clone the first condition of each type - if (TDim == 2 && numConditions > 0) - { - const CondGeometries2D IndexGeom0 = Line; - mpRefCondition[IndexGeom0] = pConditions.begin()->Create(0, pConditions.begin()->GetGeometry(), pConditions.begin()->pGetProperties()); - } - else - { - const CondGeometries3D IndexGeom0 = Triangle3D; - const CondGeometries3D IndexGeom1 = Quadrilateral3D; - - for(unsigned int i = 0; i < numConditions; i++) - { - auto itCond = pConditions.begin() + i; - - if ((itCond->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Triangle3D3 && mInitRefCondition[IndexGeom0] == false) // Triangle - { - mpRefCondition[IndexGeom0] = itCond->Create(0, itCond->GetGeometry(), itCond->pGetProperties()); - mInitRefCondition[IndexGeom0] = true; - } - else if ((itCond->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Quadrilateral3D4 && mInitRefCondition[IndexGeom1] == false) // Quadrilateral - { - mpRefCondition[IndexGeom1] = itCond->Create(0, itCond->GetGeometry(), itCond->pGetProperties()); - mInitRefCondition[IndexGeom1] = true; - } - - if (mInitRefCondition[IndexGeom0] == true && mInitRefCondition[IndexGeom1] == true) - { - break; - } - } - - } -// #pragma omp parallel for - for(unsigned int i = 0; i < numConditions; i++) - { - auto itCond = pConditions.begin() + i; - - SetConditions(itCond->GetGeometry(), CondColors[itCond->Id()], i + 1); - } - - /* Elements */ - // We clone the first element of each type - if (TDim == 2 && numElements > 0) - { - const ElemGeometries2D IndexGeom0 = Triangle2D; - mpRefElement[IndexGeom0] = pElements.begin()->Create(0, pElements.begin()->GetGeometry(), pElements.begin()->pGetProperties()); - } - else - { - const ElemGeometries3D IndexGeom0 = Tetrahedra; - const ElemGeometries3D IndexGeom1 = Prism; - - for(unsigned int i = 0; i < numElements; i++) - { - auto itElem = pElements.begin() + i; - - if ((itElem->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Tetrahedra3D4 && mInitRefElement[IndexGeom0] == false) // Tetrahedra - { - mpRefElement[IndexGeom0] = itElem->Create(0, itElem->GetGeometry(), itElem->pGetProperties()); - mInitRefElement[IndexGeom0] = true; - } - else if ((itElem->GetGeometry()).GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Quadrilateral3D4 && mInitRefElement[IndexGeom1] == false) // Prism - { - mpRefElement[IndexGeom1] = itElem->Create(0, itElem->GetGeometry(), itElem->pGetProperties()); - mInitRefElement[IndexGeom1] = true; - } - - if (mInitRefElement[IndexGeom0] == true && mInitRefElement[IndexGeom1] == true) - { - break; - } - } - - } -// #pragma omp parallel for - for(unsigned int i = 0; i < numElements; i++) - { - auto itElem = pElements.begin() + i; - - SetElements(itElem->GetGeometry(), ElemColors[itElem->Id()], i + 1); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - /** - * We initialize the metrics of the MMG sol using a level set approach - */ - - void InitializeSolData() - { - ////////* SOLUTION FILE *//////// - - // Iterate in the nodes - NodesArrayType& pNode = mrThisModelPart.Nodes(); - auto numNodes = pNode.end() - pNode.begin(); - - SetSolSize(numNodes); - -// #pragma omp parallel for - for(unsigned int i = 0; i < numNodes; i++) - { - auto itNode = pNode.begin() + i; - - #ifdef KRATOS_DEBUG - if( itNode->Has(MMG_METRIC) == false) - { - KRATOS_ERROR << " MMG_METRIC not defined for node " << itNode->Id(); - } - #endif - - // We get the metric - const Vector& Metric = itNode->GetValue(MMG_METRIC); - - #ifdef KRATOS_DEBUG - if(Metric.size() != TDim * 3 - 3) - { - KRATOS_ERROR << "Wrong size of vector MMG_METRIC found for node " << itNode->Id() << " size is " << Metric.size() << " expected size was " << TDim * 3 - 3; - } - #endif - - // We set the metric - SetMetricTensor(Metric, i + 1); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - /** - * We execute the MMg library and build the new model part from the old model part - */ - - void ExecuteRemeshing() - { - // Getting the parameters - const bool SaveToFile = mThisParameters["save_external_files"].GetBool(); - - // We initialize some values - const unsigned int StepDataSize = mrThisModelPart.GetNodalSolutionStepDataSize(); - const unsigned int BufferSize = mrThisModelPart.NodesBegin()->GetBufferSize(); - - mThisParameters["step_data_size"].SetInt(StepDataSize); - mThisParameters["buffer_size"].SetInt(BufferSize); - - if (mEchoLevel > 0) - { - std::cout << "Step data size: " << StepDataSize << " Buffer size: " << BufferSize << std::endl; - } - - ////////* MMG LIBRARY CALL *//////// - if (mEchoLevel > 0) - { - std::cout << "////////* MMG LIBRARY CALL *////////" << std::endl; - } - - MMGLibCall(); - - const unsigned int nNodes = mmgMesh->np; - array_1d nConditions; - if (TDim == 2) - { - nConditions[0] = mmgMesh->na; - } - else - { - nConditions[0] = mmgMesh->nt; - nConditions[1] = mmgMesh->nquad; - } - array_1d nElements; - if (TDim == 2) - { - nElements[0] = mmgMesh->nt; - } - else - { - nElements[0] = mmgMesh->ne; - nElements[1] = mmgMesh->nprism; - } - - if (mEchoLevel > 0) - { - std::cout << " Nodes created: " << nNodes << std::endl; - if (TDim == 2) // 2D - { - std::cout << "Conditions created: " << nConditions[0] << std::endl; - std::cout << "Elements created: " << nElements[0] << std::endl; - } - else // 3D - { - std::cout << "Conditions created: " << nConditions[0] + nConditions[1] << std::endl; - std::cout << "\tTriangles: " << nConditions[0] << "\tQuadrilaterals: " << nConditions[1]<< std::endl; - std::cout << "Elements created: " << nElements[0] + nElements[1] << std::endl; - std::cout << "\tTetrahedron: " << nElements[0] << "\tPrisms: " << nElements[1] << std::endl; - } - } - - ////////* EMPTY AND BACKUP THE MODEL PART *//////// - - ModelPart rOldModelPart; - - // First we empty the model part - for (NodeConstantIterator itNode = mrThisModelPart.NodesBegin(); itNode != mrThisModelPart.NodesEnd(); itNode++) - { - itNode->Set(TO_ERASE, true); - rOldModelPart.AddNode(*(itNode.base())); - } - mrThisModelPart.RemoveNodesFromAllLevels(TO_ERASE); - - for (ConditionConstantIterator itCond = mrThisModelPart.ConditionsBegin(); itCond != mrThisModelPart.ConditionsEnd(); itCond++) - { - itCond->Set(TO_ERASE, true); - } - mrThisModelPart.RemoveConditionsFromAllLevels(TO_ERASE); - - for (ElementConstantIterator itElem = mrThisModelPart.ElementsBegin(); itElem != mrThisModelPart.ElementsEnd(); itElem++) - { - itElem->Set(TO_ERASE, true); - rOldModelPart.AddElement(*(itElem.base())); - } - mrThisModelPart.RemoveElementsFromAllLevels(TO_ERASE); - - // Create a new model part - /* NODES */ - for (int unsigned iNode = 1; iNode <= nNodes; iNode++) - { - int ref, isRequired; - NodeType::Pointer pNode = CreateNode(iNode, ref, isRequired); - - // Set the DOFs in the nodes - for (typename Node<3>::DofsContainerType::const_iterator itDoF = mDofs.begin(); itDoF != mDofs.end(); itDoF++) - { - pNode->pAddDof(*itDoF); - } - - if (ref != 0) // NOTE: ref == 0 is the MainModelPart - { - std::vector ColorList = mColors[ref]; - for (unsigned int colors = 0; colors < ColorList.size(); colors++) - { - std::string SubModelPartName = ColorList[colors]; - ModelPart& SubModelPart = mrThisModelPart.GetSubModelPart(SubModelPartName); - SubModelPart.AddNode(pNode); - } - } - } - - /* CONDITIONS */ - unsigned int CondId = 1; - if (mpRefCondition[0] != nullptr) - { - unsigned int CounterCond0 = 0; - const std::vector ConditionToRemove0 = CheckConditions0(); - int PropId, isRequired; - for (int unsigned iCond = 1; iCond <= nConditions[0]; iCond++) - { - bool SkipCreation = false; - if (CounterCond0 < ConditionToRemove0.size()) - { - if (ConditionToRemove0[CounterCond0] == iCond) - { - SkipCreation = true; - CounterCond0 += 1; - } - } - ConditionType::Pointer pCondition = CreateCondition0(CondId, PropId, isRequired, SkipCreation); - - if (pCondition != nullptr) - { - mrThisModelPart.AddCondition(pCondition); - - if (PropId != 0) // NOTE: PropId == 0 is the MainModelPart - { - std::vector ColorList = mColors[PropId]; - for (unsigned int iColors = 0; iColors < ColorList.size(); iColors++) - { - std::string SubModelPartName = ColorList[iColors]; - ModelPart& SubModelPart = mrThisModelPart.GetSubModelPart(SubModelPartName); - SubModelPart.AddCondition(pCondition); - } - } - - CondId += 1; - } - } - } - if (TDim == 3) - { - if (mpRefCondition[1] != nullptr) // Quadrilateral - { - unsigned int CounterCond1 = 0; - const std::vector ConditionToRemove1 = CheckConditions1(); - int PropId, isRequired; - for (int unsigned iCond = 1; iCond <= nConditions[1]; iCond++) - { - bool SkipCreation = false; - if (CounterCond1 < ConditionToRemove1.size()) - { - if (ConditionToRemove1[CounterCond1] == iCond) - { - SkipCreation = true; - CounterCond1 += 1; - } - } - ConditionType::Pointer pCondition = CreateCondition1(CondId, PropId, isRequired, SkipCreation); - - if (pCondition != nullptr) - { - mrThisModelPart.AddCondition(pCondition); - - if (PropId != 0) // NOTE: PropId == 0 is the MainModelPart - { - std::vector ColorList = mColors[PropId]; - for (unsigned int iColors = 0; iColors < ColorList.size(); iColors++) - { - std::string SubModelPartName = ColorList[iColors]; - ModelPart& SubModelPart = mrThisModelPart.GetSubModelPart(SubModelPartName); - SubModelPart.AddCondition(pCondition); - } - } - - CondId += 1; - } - } - } - } - - /* ELEMENTS */ - unsigned int ElemId = 1; - if (mpRefElement[0] != nullptr) - { - unsigned int CounterElem0 = 0; - const std::vector ElementsToRemove0 = CheckElements0(); - int PropId, isRequired; - for (int unsigned i_elem = 1; i_elem <= nElements[0]; i_elem++) - { - bool SkipCreation = false; - if (CounterElem0 < ElementsToRemove0.size()) - { - if (ElementsToRemove0[CounterElem0] == i_elem) - { - SkipCreation = true; - CounterElem0 += 1; - } - } - ElementType::Pointer pElement = CreateElement0(ElemId, PropId, isRequired, SkipCreation); - - if (pElement != nullptr) - { - mrThisModelPart.AddElement(pElement); - - if (PropId != 0) // NOTE: PropId == 0 is the MainModelPart - { - std::vector ColorList = mColors[PropId]; - for (unsigned int iColors = 0; iColors < ColorList.size(); iColors++) - { - std::string SubModelPartName = ColorList[iColors]; - ModelPart& SubModelPart = mrThisModelPart.GetSubModelPart(SubModelPartName); - SubModelPart.AddElement(pElement); - } - } - - ElemId += 1; - } - } - } - if (TDim == 3) - { - if (mpRefElement[1] != nullptr) // Prism - { - unsigned int CounterElem1 = 0; - const std::vector ElementsToRemove1 = CheckElements1(); - int PropId, isRequired; - for (int unsigned i_elem = 1; i_elem <= nElements[1]; i_elem++) - { - bool SkipCreation = false; - if (CounterElem1 < ElementsToRemove1.size()) - { - if (ElementsToRemove1[CounterElem1] == i_elem) - { - SkipCreation = true; - CounterElem1 += 1; - } - } - ElementType::Pointer pElement = CreateElement1(ElemId, PropId, isRequired,SkipCreation); - - if (pElement != nullptr) - { - mrThisModelPart.AddElement(pElement); - - if (PropId != 0) // NOTE: PropId == 0 is the MainModelPart - { - std::vector ColorList = mColors[PropId]; - for (unsigned int iColors = 0; iColors < ColorList.size(); iColors++) - { - std::string SubModelPartName = ColorList[iColors]; - ModelPart& SubModelPart = mrThisModelPart.GetSubModelPart(SubModelPartName); - SubModelPart.AddElement(pElement); - } - } - - ElemId += 1; - } - } - } - } - - // Get the list of submodelparts names - const std::vector SubModelPartNames = mrThisModelPart.GetSubModelPartNames(); - - // Add the nodes to the differents submodelparts - for (unsigned int iModelPart = 0; iModelPart < mrThisModelPart.NumberOfSubModelParts(); iModelPart++) - { - ModelPart& rSubModelPart = mrThisModelPart.GetSubModelPart(SubModelPartNames[iModelPart]); - - std::set AuxSet; - - for (ElementConstantIterator itElem = rSubModelPart.ElementsBegin(); itElem != rSubModelPart.ElementsEnd(); itElem++) - { - for (unsigned int iNode = 0; iNode < itElem->GetGeometry().size(); iNode++) - { - AuxSet.insert(itElem->GetGeometry()[iNode].Id()); - } - } - - for (ConditionConstantIterator itCond = rSubModelPart.ConditionsBegin(); itCond != rSubModelPart.ConditionsEnd(); itCond++) - { - for (unsigned int iNode = 0; iNode < itCond->GetGeometry().size(); iNode++) - { - AuxSet.insert(itCond->GetGeometry()[iNode].Id()); - } - } - - // Clean duplicated nodes - std::vector NodesIds; - for( auto it = AuxSet.begin(); it != AuxSet.end(); ++it ) - { - NodesIds.push_back(*it); - } - - rSubModelPart.AddNodes(NodesIds); - } - - /* Save to file */ - if (SaveToFile == true) - { - SaveSolutionToFile(true); - } - - /* Free memory */ - FreeMemory(); - - /* After that we reorder nodes, conditions and elements: */ - ReorderAllIds(); - - /* We interpolate all the values */ - Parameters InterpolateParameters = Parameters(R"({"echo_level": 1, "framework": "Eulerian", "max_number_of_searchs": 1000, "step_data_size": 0, "buffer_size": 0})" ); - InterpolateParameters["echo_level"].SetInt(mThisParameters["echo_level"].GetInt()); - InterpolateParameters["framework"].SetString(mThisParameters["framework"].GetString()); - InterpolateParameters["max_number_of_searchs"].SetInt(mThisParameters["max_number_of_searchs"].GetInt()); - InterpolateParameters["step_data_size"].SetInt(mThisParameters["step_data_size"].GetInt()); - InterpolateParameters["buffer_size"].SetInt(mThisParameters["buffer_size"].GetInt()); - NodalValuesInterpolationProcess InterpolateNodalValues = NodalValuesInterpolationProcess(rOldModelPart, mrThisModelPart, InterpolateParameters); - InterpolateNodalValues.Execute(); - - /* We initialize elements and conditions */ - InitializeElementsAndConditions(); - - /* We interpolate the internal variables */ - if (mFramework == Lagrangian) - { - InternalVariablesInterpolationProcess InternalVariablesInterpolation = InternalVariablesInterpolationProcess(rOldModelPart, mrThisModelPart, mThisParameters["internal_variables_parameters"]); - InternalVariablesInterpolation.Execute(); - } - } - - /** - * This function reorder the nodes, conditions and elements to avoid problems with non-consecutive ids - */ - - void ReorderAllIds() - { - NodesArrayType& pNode = mrThisModelPart.Nodes(); - auto numNodes = pNode.end() - pNode.begin(); - - for(unsigned int i = 0; i < numNodes; i++) - { - auto itNode = pNode.begin() + i; - itNode->SetId(i + 1); - } - - ConditionsArrayType& pCondition = mrThisModelPart.Conditions(); - auto numConditions = pCondition.end() - pCondition.begin(); - - for(unsigned int i = 0; i < numConditions; i++) - { - auto itCondition = pCondition.begin() + i; - itCondition->SetId(i + 1); - } - - ElementsArrayType& pElement = mrThisModelPart.Elements(); - auto numElements = pElement.end() - pElement.begin(); - - for(unsigned int i = 0; i < numElements; i++) - { - auto itElement = pElement.begin() + i; - itElement->SetId(i + 1); - } - } - - /** - * After we have transfer the information from the previous modelpart we initilize the elements and conditions - */ - - void InitializeElementsAndConditions() - { - ConditionsArrayType& pCondition = mrThisModelPart.Conditions(); - auto numConditions = pCondition.end() - pCondition.begin(); - - for(unsigned int i = 0; i < numConditions; i++) - { - auto itCondition = pCondition.begin() + i; - itCondition->Initialize(); - } - - ElementsArrayType& pElement = mrThisModelPart.Elements(); - auto numElements = pElement.end() - pElement.begin(); - - for(unsigned int i = 0; i < numElements; i++) - { - auto itElement = pElement.begin() + i; - itElement->Initialize(); - } - } - - /** - * It checks if the nodes are repeated and remove the repeated ones - */ - - std::vector CheckNodes() - { - typedef boost::unordered_map, unsigned int, KeyHasherVector, KeyComparorVector > HashMap; - HashMap NodeMap; - - std::vector NodesToRemoveIds; - - vector Coords(TDim); - - NodesArrayType& pNode = mrThisModelPart.Nodes(); - auto numNodes = pNode.end() - pNode.begin(); - - for(unsigned int i = 0; i < numNodes; i++) - { - auto itNode = pNode.begin() + i; - - const array_1d Coordinates = itNode->Coordinates(); - - for(unsigned int iCoord = 0; iCoord < TDim; iCoord++) - { - Coords[iCoord] = Coordinates[iCoord]; - } - - NodeMap[Coords] += 1; - - if (NodeMap[Coords] > 1) - { - NodesToRemoveIds.push_back(itNode->Id()); - if (mEchoLevel > 0) - { - std::cout << "The mode " << itNode->Id() << " is repeated"<< std::endl; - } - } - } - - return NodesToRemoveIds; - } - - /** - * It checks if the conditions are repeated and remove the repeated ones - */ - - std::vector CheckConditions0(); - std::vector CheckConditions1(); - - /** - * It checks if the elemenst are removed and remove the repeated ones - */ - - std::vector CheckElements0(); - std::vector CheckElements1(); - - /** - * It blocks certain nodes before remesh the model - * @param iNode: The index of the noode - */ - - void BlockNode(unsigned int iNode); - - /** - * It creates the new node - * @param iNode: The index of the new noode - * @param ref: The submodelpart id - * @param isRequired: MMG value (I don't know that it does) - * @return pNode: The pointer to the new node created - */ - - NodeType::Pointer CreateNode( - unsigned int iNode, - int& ref, - int& isRequired - ); - - /** - * It creates the new condition - * @param CondId: The id of the condition - * @param PropId: The submodelpart id - * @param isRequired: MMG value (I don't know that it does) - * @return pCondition: The pointer to the new condition created - */ - - ConditionType::Pointer CreateCondition0( - const unsigned int CondId, - int& PropId, - int& isRequired, - bool SkipCreation - ); - - ConditionType::Pointer CreateCondition1( - const unsigned int CondId, - int& PropId, - int& isRequired, - bool SkipCreation - ); - - /** - * It creates the new element - * @param CondId: The id of the element - * @param PropId: The submodelpart id - * @param isRequired: MMG value (I don't know that it does) - * @return pElement: The pointer to the new condition created - */ - - ElementType::Pointer CreateElement0( - const unsigned int ElemId, - int& PropId, - int& isRequired, - bool SkipCreation - ); - - ElementType::Pointer CreateElement1( - const unsigned int ElemId, - int& PropId, - int& isRequired, - bool SkipCreation - ); - - /** - * It saves the solution and mesh to files (for debugging pourpose g.e) - * @param PostOutput: If the file to save is after or before remeshing - */ - - void SaveSolutionToFile(const bool PostOutput) - { - /* GET RESULTS */ - - const unsigned int step = mrThisModelPart.GetProcessInfo()[TIME_STEPS]; - - // Automatically save the mesh - OutputMesh(PostOutput, step); - - // Automatically save the solution - OutputSol(PostOutput, step); - } - - /** - * It frees the memory used during all the process - */ - - void FreeMemory() - { - // Free the MMG structures - FreeAll(); - - // Free filename (NOTE: Problems with more that one iteration) -// free(mFilename); -// mFilename = NULL; - - // Free reference std::vectors - mpRefElement.resize(TDim - 1); - mpRefCondition.resize(TDim - 1); - mInitRefCondition.resize(TDim - 1); - mInitRefElement.resize(TDim - 1); - for (unsigned int i_dim = 0; i_dim < TDim - 1; i_dim++) - { - mpRefElement[i_dim] = nullptr; - mInitRefCondition[i_dim] = false; - mpRefCondition[i_dim] = nullptr; - mInitRefElement[i_dim] = false; - } - } - - /** - * Initialisation of mesh and sol structures - * args of InitMesh: - * MMG5_ARG_start: we start to give the args of a variadic func - * MMG5_ARG_ppMesh: next arg will be a pointer over a MMG5_pMesh - * &mmgMesh: pointer toward your MMG5_pMesh (that store your mesh) - * MMG5_ARG_ppMet: next arg will be a pointer over a MMG5_pSol storing a metric - * &mmgSol: pointer toward your MMG5_pSol (that store your metric) - */ - - void InitMesh(); - - /** - * Here the verbosity is set - */ - - void InitVerbosity() - { - /* We set the MMG verbosity */ - int verbosityMMG; - if (mEchoLevel == 0) - { - verbosityMMG = 0; - } - else if (mEchoLevel == 1) - { - verbosityMMG = 0; // NOTE: This way just the essential info from MMG will be printed, but the custom message will appear - } - else if (mEchoLevel == 2) - { - verbosityMMG = 3; - } - else if (mEchoLevel == 3) - { - verbosityMMG = 5; - } - else if (mEchoLevel == 4) - { - std::cout << " `@@@@' .@@@@+ :@` @' `@@@@@ :@@@@@+ @@@@@@@@ @, @: @@@@@@ `@@ @@, @@@@@@ @@@@@ @ @ '@ `@: "<< std::endl; - std::cout << " `@ @' .@ @' @;@ @' @, , :@ @: @, @: @` `@@ @@, @ @+ ` @ @ '@ @;@ "<< std::endl; - std::cout << " `@ '@ .@ +@ @ @ @' @ :@ @: @, @: @` `@+; ,#@, @ @ @ @ '@ @ @ "<< std::endl; - std::cout << " `@ #@ .@ @@ ## @; @' @: :@ @: @, @: @` `@ @ @ @, @ @# @ @ '@ ;@ ## "<< std::endl; - std::cout << " `@``:@, .@::#@ @ `@ @' .@@@# :@@@@@. @: @@@@@@@: @@@@@@ `@ @ @ @, @@@@@@ @@@@` @@@@@@@ '@ @` @ "<< std::endl; - std::cout << " `@###. .@'+@# `@ @ @' ,@@ :@ @: @, @: @` `@ :#+' @, @ .#@` @ @ ;;;. '@ @ @. "<< std::endl; - std::cout << " `@ .@ @: @@@@@@# @' @, :@ @: @, @: @` `@ @@ @, @ @@ @ @ ''', '@ #@@@@@@ "<< std::endl; - std::cout << " `@ .@ `@ @ @ @' @, :@ @: @, @: @` `@ ## @, @ @@ @ @ '@ @ @ "<< std::endl; - std::cout << " `@ .@ @;;@ @, @' @,``#@ :@,,,,, @: @, @: @:,,,, `@ @, @,,,,, @:``;@` @ @ '@ .@ @' "<< std::endl; - std::cout << " `# .# `##, ;# #; ,###+ ,###### #, #, #, ###### `# #. ###### .#### # # ;# #' ,# "<< std::endl; - std::cout << " "<< std::endl; - std::cout << " "<< std::endl; - std::cout << " "<< std::endl; - std::cout << " "<< std::endl; - std::cout << " "<< std::endl; - std::cout << " ,. "<< std::endl; - std::cout << " ;;;, "<< std::endl; - std::cout << " ;;;: "<< std::endl; - std::cout << " :: "<< std::endl; - std::cout << " ; ; "<< std::endl; - std::cout << " . "<< std::endl; - std::cout << " ; "<< std::endl; - std::cout << " ` : "<< std::endl; - std::cout << " . : "<< std::endl; - std::cout << " : "<< std::endl; - std::cout << " . "<< std::endl; - std::cout << " ; ; "<< std::endl; - std::cout << " ` "<< std::endl; - std::cout << " : ` "<< std::endl; - std::cout << " . ; "<< std::endl; - std::cout << " :;; ;;` "<< std::endl; - std::cout << " ;;;,..,,,,,,,,,,,;;;; "<< std::endl; - std::cout << " :;; .;;, "<< std::endl; - std::cout << " ; :` '`;. "<< std::endl; - std::cout << " ` ' ; ' "<< std::endl; - std::cout << " : ` . . ; "<< std::endl; - std::cout << " , , ` . "<< std::endl; - std::cout << " . : ; . "<< std::endl; - std::cout << " ; ; : : ; "<< std::endl; - std::cout << " . ; ; ' . "<< std::endl; - std::cout << " ; , ; : ` "<< std::endl; - std::cout << " ` ` `: ; "<< std::endl; - std::cout << " : . `;;, . "<< std::endl; - std::cout << " ;;` ; ;;;; . :;; "<< std::endl; - std::cout << " :;;; , ,.;;.,,` ' ;;;` "<< std::endl; - std::cout << " .;;: `: ,, ; `;;; "<< std::endl; - std::cout << " `;+ `. ,`;, ., '; :. :: ; ., ##: "<< std::endl; - std::cout << " `@@@ '` ;;;. ''' ;;;; , @@@; "<< std::endl; - std::cout << " @@@@ . : ;;;` .'''; :;;: ` +@@@ "<< std::endl; - std::cout << " #@@@ : ' ::. '':'' ,,: ` ; @@@@ "<< std::endl; - std::cout << " @@@: ; ' : `'` '' . : @@@. "<< std::endl; - std::cout << " @@@+ ` ; , '' ,': ` ; : .@@@ "<< std::endl; - std::cout << " #@@+ ' , . '' '' ` ' . .@@@ "<< std::endl; - std::cout << " ,@@: ` ` '' '' . ; ` @@# "<< std::endl; - std::cout << " #@@ ; ;:` '; '' :;: : @@@ "<< std::endl; - std::cout << " ,@@@ , ;;;, '; '' ;;;, @@@# "<< std::endl; - std::cout << " ; '@@@@ . ;;;, '; `': ;;;: : @@@@@` ', "<< std::endl; - std::cout << "+@@'` :@@@@@@' `' `;` ,,, '' :'` :,, ,, ` :@@@@@@#. .+@@@ "<< std::endl; - std::cout << "+@@@@@@#@@@@@@@@@@@. ;;;; . '' '' : .:;;;` `@@@@@@@@@@@@@@@@@@@ "<< std::endl; - std::cout << " #@@@@@@@@@@@@@@@@@@. ;@;;;` ` ,' `'' , .;;;@@` .@@@@@@@@@@@@@@@@@@# "<< std::endl; - std::cout << " ,@@@@@@@@; @@@@@@@@+` :@@@;;; .:;,. `.:` '''' `:. .,;:. ;;;@@@# `@@@@@@@@@;`+@@@@@@@, "<< std::endl; - std::cout << " `..` '@@@@ :@@@@+. `@@@@@;`, `,;,;;; '''' ;;;,;,` `:@@@@@: ,+@@@@: @@@@@ "<< std::endl; - std::cout << " @@@@@ +@@@@@@',. `:@@@@@@. ' `;;;. `'' .;;; : ` +@@@@@+,` `.,;+@@@@@@' @@@@@` "<< std::endl; - std::cout << " #@@@@@ '@@@@@@@@@@@@@@@@@@#, : . ,:` ,. '. .,` ,:. ; : '#@@@@@@@@@@@@@@@@@; :@@@@@` "<< std::endl; - std::cout << " ++:;#@@@;@@, :+@@@@@@@@@#', . : ,, `` .,` , ` ` `:+#@@@@@@@#'. @@`@@@@+;#@ "<< std::endl; - std::cout << " `@@@@@@@; @@ ``` : ' ' ,,:;;.,` , : , , @@ `@@@@@@@' "<< std::endl; - std::cout << " ,@@@@@#` .@@ , ` ;;;: : ' ; ` '@+ '@@@@@+ "<< std::endl; - std::cout << " :'': @@, ; ` `;,;; : ` . , @@: `::, "<< std::endl; - std::cout << " @@@ ; : .: ; . ` @@@. "<< std::endl; - std::cout << " '@@# ; : ' ,, : ; : ' , ,@@@ "<< std::endl; - std::cout << " '@@ ` ,, ' ; ' . ` '@@ "<< std::endl; - std::cout << " ; ; : ;. ; ; ` ` , . "<< std::endl; - std::cout << " ,: :;.`;` :.; ,;; ,:. "<< std::endl; - std::cout << " .;;;``````````````;;;``` :;;: `;;;``````` ;;; "<< std::endl; - std::cout << " .;;; ;;; ```...:;;;..```` ;;; ;;; "<< std::endl; - std::cout << " :: ;,. ;; ;:, ,:; "<< std::endl; - std::cout << " ; ; . . . , ; ` "<< std::endl; - std::cout << " : ` ' ` : ` : , : "<< std::endl; - std::cout << " ` : ; , ' . . ' "<< std::endl; - std::cout << " , . ' , . : : : "<< std::endl; - std::cout << " ` , ' , . . ' "<< std::endl; - std::cout << " , : ; . ' , ; ; "<< std::endl; - std::cout << " . . ` ' : . , ` ; "<< std::endl; - std::cout << " . ; ; . , ; ` ; "<< std::endl; - std::cout << " . ` ` ' ; ' , ` : "<< std::endl; - std::cout << " . ; : ` . , ; . ; "<< std::endl; - std::cout << " , . ' ; , , "<< std::endl; - std::cout << " ` ' : ` ' . ' , : "<< std::endl; - std::cout << " , , ' ; . : . "<< std::endl; - std::cout << " `` '., . '.: :` "<< std::endl; - std::cout << " `;;: ;;; .;;` ,;; ;;; ;;; "<< std::endl; - std::cout << " :;;;:::,,,,,,,,,,,;;;,:::::::::;:;:;;;;:::::::::::;;;::::;:;::::::::;;;,,::::::::::::;;; "<< std::endl; - std::cout << " ;;. ;;, .;;. :;; ;;: :;; "<< std::endl; - std::cout << " ; ; .`` ``` . , ; ` "<< std::endl; - std::cout << " , ` ' . , ' ; ' ; : . : "<< std::endl; - std::cout << " . ' . . : ` ` ` : "<< std::endl; - std::cout << " ` ` , ; ` ' ; : ; ' : : "<< std::endl; - std::cout << " ; ; : ' ` , . ` ` ` "<< std::endl; - std::cout << " , ` ' ` ' ; . , : ; . "<< std::endl; - std::cout << " : . ' . : ` ; ; , : "<< std::endl; - std::cout << " . ; ` , : ' ; . ; "<< std::endl; - std::cout << " . ` : ; ` ; ' ; ` ; "<< std::endl; - std::cout << " : ' , ` ' ' ' . . : ` "<< std::endl; - std::cout << " ` ` ' . , ; : , "<< std::endl; - std::cout << " `,: ;,; .`; '`' ;`; ,,` ,, "<< std::endl; - std::cout << " ;;; ;;; ;;: ;;; ;;; `;;; ;;; "<< std::endl; - std::cout << " ;;;..............;;;..........,,,::;;;:::::::::::::;;;:::::::::::::;;;::::,,,.......,;;;.............,;;; "<< std::endl; - std::cout << " :;; ,;; ;;, :;; ;;; ;;` ;;, "<< std::endl; - std::cout << " , ; : . ; ' ' . ' ' ; , ; "<< std::endl; - std::cout << " ` : ` : , ; . ` ` "<< std::endl; - std::cout << " , ; ' : . . ' ' ' ` : ; ; "<< std::endl; - std::cout << " ` ` ; : ' : ; . : "<< std::endl; - std::cout << " , , ' ` . ` ' ' : ' : : ` ; "<< std::endl; - std::cout << " ` ' . , : ` ` . : "<< std::endl; - std::cout << " , . ' ' . ; ' ; ' ' , : ; ; "<< std::endl; - std::cout << " ` . , , ` . ; . ` "<< std::endl; - std::cout << " , ' ' ` , ; ' ; . ' . : , ; "<< std::endl; - std::cout << " ` , : , , . ; ` . ; "<< std::endl; - std::cout << " , ` ' ; , ` ' : ' ; : . ; "<< std::endl; - std::cout << " ;;, ;;: ,:: ;;. ;:; .:: ;;; :;: "<< std::endl; - std::cout << " .;;;::::::::::::::;;;:::::::,,,,,..;;;;.............;;;.....``````;;;`````````````;;;,....,,,,,:::::;;;::::::::::::::;;; "<< std::endl; - std::cout << " ;;; ;;; ,;;: ;;; ;;; ;;; ;;; ;;; "<< std::endl; - std::cout << " `` ` +' `, `,` :'+ ` . "<< std::endl; - std::cout << " @@ ,@@ "<< std::endl; - std::cout << " @@ `@@ "<< std::endl; - std::cout << " .@@ @@ "<< std::endl; - std::cout << " :@@ @@ "<< std::endl; - std::cout << " '@@ @@ "<< std::endl; - std::cout << " #@@ @@ "<< std::endl; - std::cout << " @@@ @@ "<< std::endl; - std::cout << " @@@ @@ "<< std::endl; - std::cout << " @@# @@ "<< std::endl; - std::cout << " @@+ @@` "<< std::endl; - std::cout << " @@+ @@, "<< std::endl; - std::cout << " @@' @@' "<< std::endl; - std::cout << " @@; @@# "<< std::endl; - std::cout << " @@: @@@ "<< std::endl; - std::cout << " @@: @@@ "<< std::endl; - std::cout << " `@@, @@@ "<< std::endl; - std::cout << " `@@, @@@ "<< std::endl; - std::cout << " .@@, @@@ "<< std::endl; - std::cout << " `@@, @@@ "<< std::endl; - std::cout << " @@, @@@ "<< std::endl; - std::cout << " @@: @@@ "<< std::endl; - std::cout << " @@: @@@ "<< std::endl; - std::cout << " @@' @@# "<< std::endl; - std::cout << " @@# @@' "<< std::endl; - std::cout << " @@@ @@: "<< std::endl; - std::cout << " @@@ `@@` "<< std::endl; - std::cout << " @@@ #@@ "<< std::endl; - std::cout << " :@@@ @@@ "<< std::endl; - std::cout << " @@@, '@@@ "<< std::endl; - std::cout << " @@@ `@@@ "<< std::endl; - std::cout << " `@@@ @@@ "<< std::endl; - std::cout << " '@@@ @@@' "<< std::endl; - std::cout << " #@@@ @@@# "<< std::endl; - std::cout << " #@@@: @@@@ "<< std::endl; - std::cout << " #@@@@` +@@@@ "<< std::endl; - std::cout << " '@@@@@ :@@@@# "<< std::endl; - std::cout << " ,@@@@@# ,@@@@@' "<< std::endl; - std::cout << " @@@@@@# ,@@@@@@. "<< std::endl; - std::cout << " `@@@@@@# ,@@@@@@+ "<< std::endl; - std::cout << " +@@@@ #@@@@@: "<< std::endl; - std::cout << " @@@@ @@@@' "<< std::endl; - std::cout << " @@@@ +@@@ "<< std::endl; - std::cout << " @@@@ .@@@ "<< std::endl; - std::cout << " @@@; @@@ "<< std::endl; - std::cout << " @@@ @@@ "<< std::endl; - std::cout << " @@@ @@@ "<< std::endl; - std::cout << " @@@ ,@@. "<< std::endl; - std::cout << " @@+ @@, "<< std::endl; - std::cout << " @@. @@: "<< std::endl; - std::cout << " @@ @@: "<< std::endl; - std::cout << " @@ @@: "<< std::endl; - std::cout << " @@ '@: "<< std::endl; - std::cout << " @@ `@, "<< std::endl; - std::cout << " @, @. "<< std::endl; - std::cout << " @ @ "<< std::endl; - std::cout << " . "<< std::endl; - std::cout << " "<< std::endl; - std::cout << " "<< std::endl; - verbosityMMG = 5; - } - else - { - verbosityMMG = 10; - } - - InitVerbosityParameter(verbosityMMG); - } - - /** - * Here the verbosity is set using the API - * @param verbosityMMG: The equivalent verbosity level in the MMG API - */ - - void InitVerbosityParameter(int verbosityMMG); - - /** - * This sets the size of the mesh - * @param numNodes: Number of nodes - * @param numElements: Number of Elements - * @param numConditions: Number of Conditions - */ - - void SetMeshSize( - const int numNodes, - const array_1d numArrayElements, // NOTE: We do this tricky thing to take into account the prisms - const array_1d numArrayConditions // NOTE: We do this tricky thing to take into account the quadrilaterals - ); - - /** - * This sets the size of the solution - * @param numNodes: Number of nodes - */ - - void SetSolSize(const int numNodes); - - /** - * This checks the mesh data and prints if it is OK - */ - - void CheckMeshData(); - - /** - * This sets the output mesh - */ - - void OutputMesh( - const bool PostOutput, - const unsigned int step - ); - - /** - * This sets the output sol - */ - - void OutputSol( - const bool PostOutput, - const unsigned int step - ); - - /** - * This loads the solution - */ - - void MMGLibCall(); - - /** - * This frees the MMG structures - */ - - void FreeAll(); - - /** - * This sets the nodes of the mesh - * @param X: Coordinate X - * @param Y: Coordinate Y - * @param Z: Coordinate Z - * @param color: Reference of the node(submodelpart) - * @param index: The index number of the node - */ - - void SetNodes( - const double X, - const double Y, - const double Z, - const int color, - const int index - ); - - /** - * This sets the conditions of the mesh - * @param Geom: The geometry of the condition - * @param color: Reference of the node(submodelpart) - * @param index: The index number of the node - */ - - void SetConditions( - Geometry > & Geom, - const int color, - const int index - ); - - /** - * This sets elements of the mesh - * @param Geom: The geometry of the element - * @param color: Reference of the node(submodelpart) - * @param index: The index number of the node - */ - - void SetElements( - Geometry > & Geom, - const int color, - const int index - ); - - /** - * This functions gets the "colors", parts of a model part to process - * @param NodeColors: Map where the submodelparts and nodes are stored - * @param CondColors: Map where the submodelparts and conditions are stored - * @param ElemColors: Map where the submodelparts and elements are stored - */ - - void ComputeColors( - boost::unordered_map& NodeColors, - boost::unordered_map& CondColors, - boost::unordered_map& ElemColors - ) - { - // Initialize and create the auxiliar maps - const std::vector SubModelPartNames = mrThisModelPart.GetSubModelPartNames(); - boost::unordered_map> AuxNodeColors, AuxCondColors, AuxElemColors; - - std::vector ModelPartNames; - ModelPartNames.push_back(mrThisModelPart.Name()); - for (unsigned int i_sub = 0; i_sub < SubModelPartNames.size(); i_sub++) - { - ModelPartNames.push_back(SubModelPartNames[i_sub]); - } - - // Initialize colors - int color = 0; - for (unsigned int i_sub = 0; i_sub < ModelPartNames.size(); i_sub++) - { - mColors[i_sub].push_back(ModelPartNames[i_sub]); - - if (color > 0) - { - ModelPart& rSubModelPart = mrThisModelPart.GetSubModelPart(ModelPartNames[i_sub]); - - // Iterate in the nodes - NodesArrayType& pNode = rSubModelPart.Nodes(); - auto numNodes = pNode.end() - pNode.begin(); - - // Iterate in the conditions - ConditionsArrayType& pConditions = rSubModelPart.Conditions(); - auto numConditions = pConditions.end() - pConditions.begin(); - - // Iterate in the elements - ElementsArrayType& pElements = rSubModelPart.Elements(); - auto numElements = pElements.end() - pElements.begin(); - - /* Nodes */ - // #pragma omp parallel for - for(unsigned int i = 0; i < numNodes; i++) - { - auto itNode = pNode.begin() + i; - AuxNodeColors[itNode->Id()].insert(color); - } - - /* Conditions */ - // #pragma omp parallel for - for(unsigned int i = 0; i < numConditions; i++) - { - auto itCond = pConditions.begin() + i; - AuxCondColors[itCond->Id()].insert(color); - } - - /* Elements */ - // #pragma omp parallel for - for(unsigned int i = 0; i < numElements; i++) - { - auto itElem = pElements.begin() + i; - AuxElemColors[itElem->Id()].insert(color); - } - } - - color += 1; - } - - // The iterator for the auxiliar maps is created - typedef boost::unordered_map>::iterator itType; - - // Now detect all the cases in which a node or a cond belongs to more than one part simultaneously - boost::unordered_map, int> Combinations; - - /* Nodes */ - for(itType iterator = AuxNodeColors.begin(); iterator != AuxNodeColors.end(); iterator++) - { -// const int key = iterator->first; - const std::set Value = iterator->second; - - if (Value.size() > 1) - { - Combinations[Value] = -1; - } - } - - /* Conditions */ - for(itType iterator = AuxCondColors.begin(); iterator != AuxCondColors.end(); iterator++) - { -// const int key = iterator->first; - const std::set Value = iterator->second; - - if (Value.size() > 1) - { - Combinations[Value] = -1; - } - } - - /* Elements */ - for(itType iterator = AuxElemColors.begin(); iterator != AuxElemColors.end(); iterator++) - { -// const int key = iterator->first; - const std::set Value = iterator->second; - - if (Value.size() > 1) - { - Combinations[Value] = -1; - } - } - - /* Combinations */ - typedef boost::unordered_map,int>::iterator CombType; - for(CombType iterator = Combinations.begin(); iterator != Combinations.end(); iterator++) - { - const std::set key = iterator->first; -// const int Value = iterator->second; - - for( auto it = key.begin(); it != key.end(); ++it ) - { - mColors[color].push_back(mColors[*it][0]); - } - Combinations[key] = color; - color += 1; - - } - - // The final maps are created - /* Nodes */ - for(itType iterator = AuxNodeColors.begin(); iterator != AuxNodeColors.end(); iterator++) - { - const int key = iterator->first; - const std::set Value = iterator->second; - - if (Value.size() == 0) - { - NodeColors[key] = 0; // Main Model Part - } - else if (Value.size() == 1) // Another Model Part - { - NodeColors[key] = *Value.begin(); - } - else // There is a combination - { - NodeColors[key] = Combinations[Value]; - } - } - - /* Conditions */ - for(itType iterator = AuxCondColors.begin(); iterator != AuxCondColors.end(); iterator++) - { - const int key = iterator->first; - const std::set Value = iterator->second; - - if (Value.size() == 0) - { - CondColors[key] = 0; // Main Model Part - } - else if (Value.size() == 1) // Another Model Part - { - CondColors[key] = *Value.begin(); - } - else // There is a combination - { - CondColors[key] = Combinations[Value]; - } - } - - /* Elements */ - for(itType iterator = AuxElemColors.begin(); iterator != AuxElemColors.end(); iterator++) - { - const int key = iterator->first; - const std::set Value = iterator->second; - - if (Value.size() == 0) - { - ElemColors[key] = 0; // Main Model Part - } - else if (Value.size() == 1) // Another Model Part - { - ElemColors[key] = *Value.begin(); - } - else // There is a combination - { - ElemColors[key] = Combinations[Value]; - } - } - } - - /** - * This function is used to compute the Hessian metric tensor, note that when using the Hessian, more than one metric can be defined simultaneously, so in consecuence we need to define the elipsoid which defines the volume of maximal intersection - * @param Metric: This array contains the components of the metric tensor in the MMG defined order - */ - - void SetMetricTensor( - const Vector& Metric, - const int NodeId - ); - - /** - * This converts the framework string to an enum - * @param str: The string - * @return FrameworkEulerLagrange: The equivalent enum - */ - - FrameworkEulerLagrange ConvertFramework(const std::string& str) - { - if(str == "Lagrangian") - { - return Lagrangian; - } - else if(str == "Eulerian") - { - return Eulerian; - } - else - { - return Eulerian; - } - } - - ///@} - ///@name Protected Access - ///@{ - - ///@} - ///@name Protected Inquiry - ///@{ - - ///@} - ///@name Protected LifeCycle - ///@{ - - ///@} -};// class MmgUtility -///@} - -///@name Explicit Specializations -///@{ - - template<> - std::vector MmgUtility<2>::CheckConditions0() - { - typedef boost::unordered_map, unsigned int, KeyHasherVector, KeyComparorVector > HashMap; - HashMap edge_map; - - vector ids(2); - - std::vector ConditionsToRemove; - - // Iterate in the conditions - for(int i = 0; i < mmgMesh->na; i++) - { - int edge0, edge1, PropId, isRidge, isRequired; - - if (MMG2D_Get_edge(mmgMesh, &edge0, &edge1, &PropId, &isRidge, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - ids[0] = edge0; - ids[1] = edge1; - - //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** - std::sort(ids.begin(), ids.end()); - - edge_map[ids] += 1; - - if (edge_map[ids] > 1) - { - ConditionsToRemove.push_back(i + 1); - } - } - - return ConditionsToRemove; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - std::vector MmgUtility<3>::CheckConditions0() - { - typedef boost::unordered_map, unsigned int, KeyHasherVector, KeyComparorVector > HashMap; - HashMap TriangleMap; - - vector IdsTriangles(3); - - std::vector ConditionsToRemove; - - for(int i = 0; i < mmgMesh->nt; i++) - { - int Vertex0, Vertex1, Vertex2, PropId, isRequired; - - if (MMG3D_Get_triangle(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - IdsTriangles[0] = Vertex0; - IdsTriangles[1] = Vertex1; - IdsTriangles[2] = Vertex2; - - //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** - std::sort(IdsTriangles.begin(), IdsTriangles.end()); - - TriangleMap[IdsTriangles] += 1; - - if (TriangleMap[IdsTriangles] > 1) - { - ConditionsToRemove.push_back(i + 1); - } - } - - return ConditionsToRemove; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - std::vector MmgUtility<3>::CheckConditions1() - { - typedef boost::unordered_map, unsigned int, KeyHasherVector, KeyComparorVector > HashMap; - HashMap QuadrilateralMap; - - vector IdsQuadrilateral(4); - - std::vector ConditionsToRemove; - - for(int i = 0; i < mmgMesh->nquad; i++) - { - int Vertex0, Vertex1, Vertex2, Vertex3, PropId, isRequired; - - if (MMG3D_Get_quadrilateral(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &Vertex3, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - IdsQuadrilateral[0] = Vertex0; - IdsQuadrilateral[1] = Vertex1; - IdsQuadrilateral[2] = Vertex2; - IdsQuadrilateral[3] = Vertex3; - - //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** - std::sort(IdsQuadrilateral.begin(), IdsQuadrilateral.end()); - - QuadrilateralMap[IdsQuadrilateral] += 1; - - if (QuadrilateralMap[IdsQuadrilateral] > 1) - { - ConditionsToRemove.push_back(i + 1); - } - } - - return ConditionsToRemove; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - std::vector MmgUtility<2>::CheckElements0() - { - typedef boost::unordered_map, unsigned int, KeyHasherVector, KeyComparorVector > HashMap; - HashMap TriangleMap; - - vector IdsTriangles(3); - - std::vector ElementsToRemove; - - // Iterate in the elements - for(int i = 0; i < mmgMesh->nt; i++) - { - int Vertex0, Vertex1, Vertex2, PropId, isRequired; - - if (MMG2D_Get_triangle(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - IdsTriangles[0] = Vertex0; - IdsTriangles[1] = Vertex1; - IdsTriangles[2] = Vertex2; - - //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** - std::sort(IdsTriangles.begin(), IdsTriangles.end()); - - TriangleMap[IdsTriangles] += 1; - - if (TriangleMap[IdsTriangles] > 1) - { - ElementsToRemove.push_back(i + 1); - } - } - - return ElementsToRemove; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - std::vector MmgUtility<3>::CheckElements0() - { - typedef boost::unordered_map, unsigned int, KeyHasherVector, KeyComparorVector > HashMap; - HashMap TriangleMap; - - vector IdsTetrahedron(4); - - std::vector ElementsToRemove; - - for(int i = 0; i < mmgMesh->ne; i++) - { - int Vertex0, Vertex1, Vertex2, Vertex3, PropId, isRequired; - - if (MMG3D_Get_tetrahedron(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &Vertex3, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - IdsTetrahedron[0] = Vertex0; - IdsTetrahedron[1] = Vertex1; - IdsTetrahedron[2] = Vertex2; - IdsTetrahedron[3] = Vertex3; - - //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** - std::sort(IdsTetrahedron.begin(), IdsTetrahedron.end()); - - TriangleMap[IdsTetrahedron] += 1; - - if (TriangleMap[IdsTetrahedron] > 1) - { - ElementsToRemove.push_back(i + 1); - } - } - - return ElementsToRemove; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - std::vector MmgUtility<3>::CheckElements1() - { - typedef boost::unordered_map, unsigned int, KeyHasherVector, KeyComparorVector > HashMap; - HashMap PrismMap; - - vector IdsPrisms(6); - - std::vector ElementsToRemove; - - for(int i = 0; i < mmgMesh->nprism; i++) - { - int Vertex0, Vertex1, Vertex2, Vertex3, Vertex4, Vertex5, PropId, isRequired; - - if (MMG3D_Get_prism(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &Vertex3, &Vertex4, &Vertex5, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - IdsPrisms[0] = Vertex0; - IdsPrisms[1] = Vertex1; - IdsPrisms[2] = Vertex2; - IdsPrisms[3] = Vertex3; - IdsPrisms[4] = Vertex4; - IdsPrisms[5] = Vertex5; - - //*** THE ARRAY OF IDS MUST BE ORDERED!!! *** - std::sort(IdsPrisms.begin(), IdsPrisms.end()); - - PrismMap[IdsPrisms] += 1; - - if (PrismMap[IdsPrisms] > 1) - { - ElementsToRemove.push_back(i + 1); - } - } - - return ElementsToRemove; - } - - /***********************************************************************************/ - /***********************************************************************************/ - -// template<> // NOTE: Not yet avalaible in the official API -// void MmgUtility<2>::BlockNode(unsigned int iNode) -// { -// if (MMG2D_Set_requiredVertex(mmgMesh, iNode) != 1 ) -// { -// exit(EXIT_FAILURE); -// } -// } - - /***********************************************************************************/ - /***********************************************************************************/ - - - template<> - void MmgUtility<3>::BlockNode(unsigned int iNode) - { - if (MMG3D_Set_requiredVertex(mmgMesh, iNode) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - NodeType::Pointer MmgUtility<2>::CreateNode( - unsigned int iNode, - int& ref, - int& isRequired - ) - { - double Coord0, Coord1; - int isCorner; - - if (MMG2D_Get_vertex(mmgMesh, &Coord0, &Coord1, &ref, &isCorner, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - NodeType::Pointer pNode = mrThisModelPart.CreateNewNode(iNode, Coord0, Coord1, 0.0); - - return pNode; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - NodeType::Pointer MmgUtility<3>::CreateNode( - unsigned int iNode, - int& ref, - int& isRequired - ) - { - double Coord0, Coord1, Coord2; - int isCorner; - - if (MMG3D_Get_vertex(mmgMesh, &Coord0, &Coord1, &Coord2, &ref, &isCorner, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - NodeType::Pointer pNode = mrThisModelPart.CreateNewNode(iNode, Coord0, Coord1, Coord2); - - return pNode; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - ConditionType::Pointer MmgUtility<2>::CreateCondition0( - const unsigned int CondId, - int& PropId, - int& isRequired, - bool SkipCreation - ) - { - ConditionType::Pointer pCondition = nullptr; - - const CondGeometries2D IndexGeom = Line; - - int Edge0, Edge1, isRidge; - - if (MMG2D_Get_edge(mmgMesh, &Edge0, &Edge1, &PropId, &isRidge, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum - if (Edge0 == 0) SkipCreation = true; - if (Edge1 == 0) SkipCreation = true; - - if (SkipCreation == false) - { - std::vector ConditionNodes (2); - ConditionNodes[0] = mrThisModelPart.pGetNode(Edge0); - ConditionNodes[1] = mrThisModelPart.pGetNode(Edge1); - - pCondition = mpRefCondition[IndexGeom]->Create(CondId, ConditionNodes, mpRefCondition[IndexGeom]->pGetProperties()); - } - else if (mEchoLevel > 0) - { - std::cout << "Condition creation avoided" << std::endl; - } - - return pCondition; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - ConditionType::Pointer MmgUtility<3>::CreateCondition0( - const unsigned int CondId, - int& PropId, - int& isRequired, - bool SkipCreation - ) - { - ConditionType::Pointer pCondition = nullptr; - - const CondGeometries3D IndexGeom = Triangle3D; - - int Vertex0, Vertex1, Vertex2; - - if (MMG3D_Get_triangle(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum - if (Vertex0 == 0) SkipCreation = true; - if (Vertex1 == 0) SkipCreation = true; - if (Vertex2 == 0) SkipCreation = true; - - if (SkipCreation == false) - { - std::vector ConditionNodes (3); - ConditionNodes[0] = mrThisModelPart.pGetNode(Vertex0); - ConditionNodes[1] = mrThisModelPart.pGetNode(Vertex1); - ConditionNodes[2] = mrThisModelPart.pGetNode(Vertex2); - - pCondition = mpRefCondition[IndexGeom]->Create(CondId, ConditionNodes, mpRefCondition[IndexGeom]->pGetProperties()); - } - else if (mEchoLevel > 0) - { - std::cout << "Condition creation avoided" << std::endl; - } - - return pCondition; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - ConditionType::Pointer MmgUtility<3>::CreateCondition1( - const unsigned int CondId, - int& PropId, - int& isRequired, - bool SkipCreation - ) - { - ConditionType::Pointer pCondition = nullptr; - - const CondGeometries3D IndexGeom = Quadrilateral3D; - - int Vertex0, Vertex1, Vertex2, Vertex3; - - if (MMG3D_Get_quadrilateral(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &Vertex3, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum - if (Vertex0 == 0) SkipCreation = true; - if (Vertex1 == 0) SkipCreation = true; - if (Vertex2 == 0) SkipCreation = true; - if (Vertex3 == 0) SkipCreation = true; - - if (SkipCreation == false) - { - std::vector ConditionNodes (4); - ConditionNodes[0] = mrThisModelPart.pGetNode(Vertex0); - ConditionNodes[1] = mrThisModelPart.pGetNode(Vertex1); - ConditionNodes[2] = mrThisModelPart.pGetNode(Vertex2); - ConditionNodes[3] = mrThisModelPart.pGetNode(Vertex3); - - pCondition = mpRefCondition[IndexGeom]->Create(CondId, ConditionNodes, mpRefCondition[IndexGeom]->pGetProperties()); - } - else if (mEchoLevel > 0) - { - std::cout << "Condition creation avoided" << std::endl; - } - - return pCondition; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - ElementType::Pointer MmgUtility<2>::CreateElement0( - const unsigned int ElemId, - int& PropId, - int& isRequired, - bool SkipCreation - ) - { - ElementType::Pointer pElement = nullptr; - - const ElemGeometries2D IndexGeom = Triangle2D; - - int Vertex0, Vertex1, Vertex2; - - if (MMG2D_Get_triangle(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum - if (Vertex0 == 0) SkipCreation = true; - if (Vertex1 == 0) SkipCreation = true; - if (Vertex2 == 0) SkipCreation = true; - - if (SkipCreation == false) - { - std::vector ElementNodes (3); - ElementNodes[0] = mrThisModelPart.pGetNode(Vertex0); - ElementNodes[1] = mrThisModelPart.pGetNode(Vertex1); - ElementNodes[2] = mrThisModelPart.pGetNode(Vertex2); - - pElement = mpRefElement[IndexGeom]->Create(ElemId, ElementNodes, mpRefElement[IndexGeom]->pGetProperties()); - } - else if (mEchoLevel > 0) - { - std::cout << "Element creation avoided" << std::endl; - } - - return pElement; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - ElementType::Pointer MmgUtility<3>::CreateElement0( - const unsigned int ElemId, - int& PropId, - int& isRequired, - bool SkipCreation - ) - { - ElementType::Pointer pElement = nullptr; - - const ElemGeometries3D IndexGeom = Tetrahedra; - - int Vertex0, Vertex1, Vertex2, Vertex3; - - if (MMG3D_Get_tetrahedron(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &Vertex3, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum - if (Vertex0 == 0) SkipCreation = true; - if (Vertex1 == 0) SkipCreation = true; - if (Vertex2 == 0) SkipCreation = true; - if (Vertex3 == 0) SkipCreation = true; - - if (SkipCreation == false) - { - std::vector ElementNodes (4); - ElementNodes[0] = mrThisModelPart.pGetNode(Vertex0); - ElementNodes[1] = mrThisModelPart.pGetNode(Vertex1); - ElementNodes[2] = mrThisModelPart.pGetNode(Vertex2); - ElementNodes[3] = mrThisModelPart.pGetNode(Vertex3); - - pElement = mpRefElement[IndexGeom]->Create(ElemId, ElementNodes, mpRefElement[IndexGeom]->pGetProperties()); - } - else if (mEchoLevel > 0) - { - std::cout << "Element creation avoided" << std::endl; - } - - return pElement; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - ElementType::Pointer MmgUtility<3>::CreateElement1( - const unsigned int ElemId, - int& PropId, - int& isRequired, - bool SkipCreation - ) - { - ElementType::Pointer pElement = nullptr; - - const ElemGeometries3D IndexGeom = Prism; - - int Vertex0, Vertex1, Vertex2, Vertex3, Vertex4, Vertex5; - - if (MMG3D_Get_prism(mmgMesh, &Vertex0, &Vertex1, &Vertex2, &Vertex3, &Vertex4, &Vertex5, &PropId, &isRequired) != 1 ) - { - exit(EXIT_FAILURE); - } - - // FIXME: This is not the correct solution to the problem, I asked in the MMG Forum - if (Vertex0 == 0) SkipCreation = true; - if (Vertex1 == 0) SkipCreation = true; - if (Vertex2 == 0) SkipCreation = true; - if (Vertex3 == 0) SkipCreation = true; - if (Vertex4 == 0) SkipCreation = true; - if (Vertex5 == 0) SkipCreation = true; - - if (SkipCreation == false) - { - std::vector ElementNodes (6); - ElementNodes[0] = mrThisModelPart.pGetNode(Vertex0); - ElementNodes[1] = mrThisModelPart.pGetNode(Vertex1); - ElementNodes[2] = mrThisModelPart.pGetNode(Vertex2); - ElementNodes[3] = mrThisModelPart.pGetNode(Vertex3); - ElementNodes[4] = mrThisModelPart.pGetNode(Vertex4); - ElementNodes[5] = mrThisModelPart.pGetNode(Vertex5); - - pElement = mpRefElement[IndexGeom]->Create(ElemId, ElementNodes, mpRefElement[IndexGeom]->pGetProperties()); - } - else if (mEchoLevel > 0) - { - std::cout << "Element creation avoided" << std::endl; - } - - return pElement; - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::InitMesh() - { - mmgMesh = NULL; - mmgSol = NULL; - - // We init the MMG mesh and sol - MMG2D_Init_mesh( MMG5_ARG_start, MMG5_ARG_ppMesh, &mmgMesh, MMG5_ARG_ppMet, &mmgSol, MMG5_ARG_end); - - InitVerbosity(); - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::InitMesh() - { - mmgMesh = NULL; - mmgSol = NULL; - - MMG3D_Init_mesh( MMG5_ARG_start, MMG5_ARG_ppMesh, &mmgMesh, MMG5_ARG_ppMet, &mmgSol, MMG5_ARG_end); - - InitVerbosity(); - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::InitVerbosityParameter(int verbosityMMG) - { - if ( !MMG2D_Set_iparameter(mmgMesh,mmgSol,MMG2D_IPARAM_verbose, verbosityMMG) ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::InitVerbosityParameter(int verbosityMMG) - { - if ( !MMG3D_Set_iparameter(mmgMesh,mmgSol,MMG3D_IPARAM_verbose, verbosityMMG) ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::SetMeshSize( - const int numNodes, - const array_1d numArrayElements, - const array_1d numArrayConditions - ) - { - //Give the size of the mesh: numNodes vertices, numElements triangles, numConditions edges (2D) - if ( MMG2D_Set_meshSize(mmgMesh, numNodes, numArrayElements[0], numArrayConditions[0]) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::SetMeshSize( - const int numNodes, - const array_1d numArrayElements, // NOTE: We do this tricky thing to take into account the prisms - const array_1d numArrayConditions // NOTE: We do this tricky thing to take into account the quadrilaterals - ) - { - //Give the size of the mesh: numNodes Vertex, numElements tetra and prism, numArrayConditions triangles and quadrilaterals, 0 edges (3D) - if ( MMG3D_Set_meshSize(mmgMesh, numNodes, numArrayElements[0], numArrayElements[1], numArrayConditions[0], numArrayConditions[1], 0) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::SetSolSize(const int numNodes) - { - if ( MMG2D_Set_solSize(mmgMesh,mmgSol,MMG5_Vertex,numNodes,MMG5_Tensor) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::SetSolSize(const int numNodes) - { - if ( MMG3D_Set_solSize(mmgMesh,mmgSol,MMG5_Vertex,numNodes,MMG5_Tensor) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::CheckMeshData() - { - if ( MMG2D_Chk_meshData(mmgMesh, mmgSol) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::CheckMeshData() - { - if ( MMG3D_Chk_meshData(mmgMesh, mmgSol) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::OutputMesh( - const bool PostOutput, - const unsigned int step - ) - { - std::string MeshName; - if (PostOutput == true) - { - MeshName = mStdStringFilename+"_step="+std::to_string(step)+".o.mesh"; - } - else - { - MeshName = mStdStringFilename+"_step="+std::to_string(step)+".mesh"; - } - - char* MeshFile = new char [MeshName.length() + 1]; - std::strcpy (MeshFile, MeshName.c_str()); - - // a) Give the ouptut mesh name using MMG2D_Set_outputMeshName (by default, the mesh is saved in the "mesh.o.mesh" file - MMG2D_Set_outputMeshName(mmgMesh,MeshFile); - - // b) function calling - if ( MMG2D_saveMesh(mmgMesh,MeshFile) != 1) - { - std::cout << "UNABLE TO SAVE MESH" << std::endl; - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::OutputMesh( - const bool PostOutput, - const unsigned int step - ) - { - std::string MeshName; - if (PostOutput == true) - { - MeshName = mStdStringFilename+"_step="+std::to_string(step)+".o.mesh"; - } - else - { - MeshName = mStdStringFilename+"_step="+std::to_string(step)+".mesh"; - } - - char* MeshFile = new char [MeshName.length() + 1]; - std::strcpy (MeshFile, MeshName.c_str()); - - // a) Give the ouptut mesh name using MMG3D_Set_outputMeshName (by default, the mesh is saved in the "mesh.o.mesh" file - MMG3D_Set_outputMeshName(mmgMesh,MeshFile); - - // b) function calling - if ( MMG3D_saveMesh(mmgMesh,MeshFile) != 1) - { - std::cout << "UNABLE TO SAVE MESH" << std::endl; - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::OutputSol( - const bool PostOutput, - const unsigned int step - ) - { - std::string SolName; - if (PostOutput == true) - { - SolName = mStdStringFilename+"_step="+std::to_string(step)+".o.sol"; - } - else - { - SolName = mStdStringFilename+"_step="+std::to_string(step)+".sol"; - } - - char* SolFile = new char [SolName.length() + 1]; - std::strcpy (SolFile, SolName.c_str()); - - // a) Give the ouptut sol name using MMG2D_Set_outputSolName (by default, the mesh is saved in the "mesh.o.sol" file - MMG2D_Set_outputSolName(mmgMesh, mmgSol, SolFile); - - // b) Function calling - if ( MMG2D_saveSol(mmgMesh, mmgSol, SolFile) != 1) - { - std::cout << "UNABLE TO SAVE SOL" << std::endl; - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::OutputSol( - const bool PostOutput, - const unsigned int step - ) - { - std::string SolName; - if (PostOutput == true) - { - SolName = mStdStringFilename+"_step="+std::to_string(step)+".o.sol"; - } - else - { - SolName = mStdStringFilename+"_step="+std::to_string(step)+".sol"; - } - - char* SolFile = new char [SolName.length() + 1]; - std::strcpy (SolFile, SolName.c_str()); - - // a) Give the ouptut sol name using MMG3D_Set_outputSolName (by default, the mesh is saved in the "mesh.o.sol" file - MMG3D_Set_outputSolName(mmgMesh, mmgSol, SolFile); - - // b) Function calling - if ( MMG3D_saveSol(mmgMesh,mmgSol, SolFile) != 1) - { - std::cout << "UNABLE TO SAVE SOL" << std::endl; - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::MMGLibCall() - { - const int ier = MMG2D_mmg2dlib(mmgMesh, mmgSol); - - if ( ier == MMG5_STRONGFAILURE ) - { - KRATOS_ERROR << "WARNING: BAD ENDING OF MMG2DLIB: UNABLE TO SAVE MESH. ier: " << ier << std::endl; - } - else if ( ier == MMG5_LOWFAILURE ) - { - KRATOS_ERROR << "WARNING: BAD ENDING OF MMG2DLIB. ier: " << ier << std::endl; - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::MMGLibCall() - { - const int ier = MMG3D_mmg3dlib(mmgMesh, mmgSol); - - if ( ier == MMG5_STRONGFAILURE ) - { - KRATOS_ERROR << "WARNING: BAD ENDING OF MMG3DLIB: UNABLE TO SAVE MESH. ier: " << ier << std::endl; - } - else if ( ier == MMG5_LOWFAILURE ) - { - KRATOS_ERROR << "WARNING: BAD ENDING OF MMG3DLIB. ier: " << ier << std::endl; - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::FreeAll() - { - MMG2D_Free_all(MMG5_ARG_start,MMG5_ARG_ppMesh,&mmgMesh,MMG5_ARG_ppMet,&mmgSol,MMG5_ARG_end); - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::FreeAll() - { - MMG3D_Free_all(MMG5_ARG_start,MMG5_ARG_ppMesh,&mmgMesh,MMG5_ARG_ppMet,&mmgSol,MMG5_ARG_end); - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::SetNodes( - const double X, - const double Y, - const double Z, - const int color, - const int index - ) - { - if ( MMG2D_Set_vertex(mmgMesh, X, Y, color, index) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::SetNodes( - const double X, - const double Y, - const double Z, - const int color, - const int index - ) - { - if ( MMG3D_Set_vertex(mmgMesh, X, Y, Z, color, index) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::SetConditions( - Geometry > & Geom, - const int color, - const int index - ) - { - const int id1 = Geom[0].Id(); // First node id - const int id2 = Geom[1].Id(); // Second node id - - if ( MMG2D_Set_edge(mmgMesh, id1, id2, color, index) != 1 ) - { - exit(EXIT_FAILURE); - } - - // Set fixed boundary - bool blocked1 = false; - if (Geom[0].IsDefined(BLOCKED) == true) - { - blocked1 = Geom[0].Is(BLOCKED); - } - bool blocked2 = false; - if (Geom[1].IsDefined(BLOCKED) == true) - { - blocked2 = Geom[1].Is(BLOCKED); - } - - if ((blocked1 && blocked2) == true) - { - if ( MMG2D_Set_requiredEdge(mmgMesh, index) != 1 ) - { - exit(EXIT_FAILURE); - } - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::SetConditions( - Geometry > & Geom, - const int color, - const int index - ) - { - const int Id1 = Geom[0].Id(); // First node Id - const int Id2 = Geom[1].Id(); // Second node Id - const int Id3 = Geom[2].Id(); // Third node Id - - if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Triangle3D3) // Triangle - { - if ( MMG3D_Set_triangle(mmgMesh, Id1, Id2, Id3, color, index) != 1 ) - { - exit(EXIT_FAILURE); - } - - // Set fixed boundary - bool blocked1 = false; - if (Geom[0].IsDefined(BLOCKED) == true) - { - blocked1 = Geom[0].Is(BLOCKED); - } - bool blocked2 = false; - if (Geom[1].IsDefined(BLOCKED) == true) - { - blocked2 = Geom[1].Is(BLOCKED); - } - bool blocked3 = false; - if (Geom[2].IsDefined(BLOCKED) == true) - { - blocked3 = Geom[2].Is(BLOCKED); - } - - if ((blocked1 && blocked2 && blocked3) == true) - { - if ( MMG3D_Set_requiredTriangle(mmgMesh, index) != 1 ) - { - exit(EXIT_FAILURE); - } - } - } - else if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Quadrilateral3D4) // Quadrilaterals - { - const int Id4 = Geom[3].Id(); // Fourth node Id - - if ( MMG3D_Set_quadrilateral(mmgMesh, Id1, Id2, Id3, Id4, color, index) != 1 ) - { - exit(EXIT_FAILURE); - } - } - else - { - const unsigned int SizeGeometry = Geom.size(); - KRATOS_ERROR << "WARNING: I DO NOT KNOW WHAT IS THIS. Size: " << SizeGeometry << std::endl; - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::SetElements( - Geometry > & Geom, - const int color, - const int index - ) - { - const int Id1 = Geom[0].Id(); // First node Id - const int Id2 = Geom[1].Id(); // Second node Id - const int Id3 = Geom[2].Id(); // Third node Id - - if ( MMG2D_Set_triangle(mmgMesh, Id1, Id2, Id3, color, index) != 1 ) - { - exit(EXIT_FAILURE); - } - - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::SetElements( - Geometry > & Geom, - const int color, - const int index - ) - { - const int Id1 = Geom[0].Id(); // First node Id - const int Id2 = Geom[1].Id(); // Second node Id - const int Id3 = Geom[2].Id(); // Third node Id - const int Id4 = Geom[3].Id(); // Fourth node Id - - if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Tetrahedra3D4) // Tetrahedron - { - if ( MMG3D_Set_tetrahedron(mmgMesh, Id1, Id2, Id3, Id4, color, index) != 1 ) - { - exit(EXIT_FAILURE); - } - } - else if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Prism3D6) // Prisms - { - const int Id5 = Geom[4].Id(); // 5th node Id - const int Id6 = Geom[5].Id(); // 6th node Id - - if ( MMG3D_Set_prism(mmgMesh, Id1, Id2, Id3, Id4, Id5, Id6, color, index) != 1 ) - { - exit(EXIT_FAILURE); - } - } - else if (Geom.GetGeometryType() == GeometryData::KratosGeometryType::Kratos_Hexahedra3D8) // Hexaedron - { -// const int Id5 = Geom[4].Id(); // 5th node Id -// const int Id6 = Geom[5].Id(); // 6th node Id -// const int Id6 = Geom[7].Id(); // 7th node Id -// const int Id6 = Geom[8].Id(); // 8th node Id - - const unsigned int SizeGeometry = Geom.size(); - KRATOS_ERROR << "WARNING: HEXAEDRON NON IMPLEMENTED IN THE LIBRARY " << SizeGeometry << std::endl; - } - else - { - const unsigned int SizeGeometry = Geom.size(); - KRATOS_ERROR << "WARNING: I DO NOT KNOW WHAT IS THIS. Size: " << SizeGeometry << std::endl; - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<2>::SetMetricTensor( - const Vector& Metric, - const int NodeId - ) - { - if ( MMG2D_Set_tensorSol(mmgSol, Metric[0], Metric[1], Metric[2], NodeId) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - /***********************************************************************************/ - /***********************************************************************************/ - - template<> - void MmgUtility<3>::SetMetricTensor( - const Vector& Metric, - const int NodeId - ) - { - if ( MMG3D_Set_tensorSol(mmgSol, Metric[0], Metric[1], Metric[2], Metric[3], Metric[4], Metric[5], NodeId) != 1 ) - { - exit(EXIT_FAILURE); - } - } - - - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - -}// namespace Kratos. -#endif /* KRATOS_MMG_UTILITY defined */ diff --git a/applications/MeshingApplication/custom_utilities/projection.h b/applications/MeshingApplication/custom_utilities/projection.h index fefdb44c0a74..8cd618c8570f 100644 --- a/applications/MeshingApplication/custom_utilities/projection.h +++ b/applications/MeshingApplication/custom_utilities/projection.h @@ -106,10 +106,10 @@ class MeshTransfer ///@{ /// Default constructor. - MeshTransfer() {} // + MeshTransfer() = default; // /// Destructor. - virtual ~MeshTransfer() {} + virtual ~MeshTransfer() = default; ///@} @@ -256,7 +256,7 @@ class MeshTransfer //check if inside - for( PointIterator it_found = Results.begin(); it_found != Results.begin() + number_of_points_in_radius; it_found++) + for( auto it_found = Results.begin(); it_found != Results.begin() + number_of_points_in_radius; it_found++) { bool is_inside = false; @@ -439,7 +439,7 @@ class MeshTransfer //check if inside - for( PointIterator it_found = Results.begin(); it_found != Results.begin() + number_of_points_in_radius; it_found++) + for( auto it_found = Results.begin(); it_found != Results.begin() + number_of_points_in_radius; it_found++) { // KRATOS_WATCH("line 402") bool is_inside = false; diff --git a/applications/MeshingApplication/custom_utilities/tetgen_volume_mesher.h b/applications/MeshingApplication/custom_utilities/tetgen_volume_mesher.h index 179234bb74f3..54838955be00 100644 --- a/applications/MeshingApplication/custom_utilities/tetgen_volume_mesher.h +++ b/applications/MeshingApplication/custom_utilities/tetgen_volume_mesher.h @@ -81,8 +81,7 @@ class TetgenVolumeMesher /// Destructor. virtual ~TetgenVolumeMesher() - { - } + = default; /** * This function is designed to add volumes, to carve out cavities inside a domain. @@ -156,7 +155,7 @@ class TetgenVolumeMesher f->numberofpolygons = 1; f->polygonlist = new tetgenio::polygon[f->numberofpolygons]; f->numberofholes = 0; - f->holelist = NULL; + f->holelist = nullptr; tetgenio::polygon* p = &f->polygonlist[0]; p->numberofvertices = 3; p->vertexlist = new int[p->numberofvertices]; @@ -183,7 +182,7 @@ class TetgenVolumeMesher // //perform meshing with tetgen // tetrahedralize(tetgen_options, &in, &out); - char *tmp=new char[settings.size()+1]; + auto tmp=new char[settings.size()+1]; tmp[settings.size()]=0; memcpy(tmp,settings.c_str(),settings.size()); diff --git a/applications/MeshingApplication/custom_utilities/tetrahedra_reconnect_utility.h b/applications/MeshingApplication/custom_utilities/tetrahedra_reconnect_utility.h index 26cbc854f44b..655139e4049f 100644 --- a/applications/MeshingApplication/custom_utilities/tetrahedra_reconnect_utility.h +++ b/applications/MeshingApplication/custom_utilities/tetrahedra_reconnect_utility.h @@ -104,7 +104,7 @@ class TetrahedraReconnectUtility } /// Destructor. - virtual ~TetrahedraReconnectUtility() {} + virtual ~TetrahedraReconnectUtility() = default; ///@} @@ -134,7 +134,7 @@ class TetrahedraReconnectUtility fPos.x = it->X(); fPos.y = it->Y(); fPos.z = it->Z(); - TVertex *v = new TVertex(fPos); + auto v = new TVertex(fPos); v->setID( it->Id() ); v->blockID = true; m->vertexes->Add(v); @@ -150,31 +150,31 @@ class TetrahedraReconnectUtility continue; } TVertex *v0 = m->findVertexById(geom[0].Id()); - if ( v0 == NULL ) + if ( v0 == nullptr ) { std::cout << "Invalid element reference" << el_it->Id(); continue; } TVertex *v1 = m->findVertexById(geom[1].Id()); - if ( v1 == NULL ) + if ( v1 == nullptr ) { std::cout << "Invalid element reference" << el_it->Id(); continue; } TVertex *v2 = m->findVertexById(geom[2].Id()); - if ( v2 == NULL ) + if ( v2 == nullptr ) { std::cout << "Invalid element reference" << el_it->Id(); continue; } TVertex *v3 = m->findVertexById(geom[3].Id()); - if ( v3 == NULL ) + if ( v3 == nullptr ) { std::cout << "Invalid element reference" << el_it->Id(); continue; } - TTetra *t = new TTetra(NULL, v0,v1,v2,v3); + auto t = new TTetra(nullptr, v0,v1,v2,v3); m->elements->Add(t); } @@ -219,7 +219,7 @@ class TetrahedraReconnectUtility for (ModelPart::NodesContainerType::iterator i_node = mrModelPart.Nodes().begin() ; i_node != mrModelPart.Nodes().end() ; i_node++) { TVertex* v = m->findVertexById(i_node->Id()); - if (v == NULL) + if (v == nullptr) { if (!shownMessage) std::cout << "Error at id "<Id() << "\n"; @@ -244,7 +244,7 @@ class TetrahedraReconnectUtility Node<3>::Pointer v1 = mrModelPart.pGetNode(t->vertexes[1]->getID()); Node<3>::Pointer v2 = mrModelPart.pGetNode(t->vertexes[2]->getID()); Node<3>::Pointer v3 = mrModelPart.pGetNode(t->vertexes[3]->getID()); - if ((v0 == NULL) || (v1==NULL) || (v2 == NULL) || (v3 == NULL)) + if ((v0 == nullptr) || (v1==nullptr) || (v2 == nullptr) || (v3 == nullptr)) { if (!messageShown) std::cout << "Invalid vertex access " << t->getID() <<"\n"; @@ -276,7 +276,7 @@ class TetrahedraReconnectUtility bool EvaluateQuality() { - TetQuality *qt = new TetQuality(m) ; + auto qt = new TetQuality(m) ; qt->refresh(); qt->print(); int numNegElements = qt->nonPositive; @@ -313,7 +313,7 @@ class TetrahedraReconnectUtility int id = it->Id(); TVertex *v = m->findVertexById(id); - if (v == NULL) + if (v == nullptr) v->fPos = fPos; } } @@ -340,7 +340,7 @@ class TetrahedraReconnectUtility bool isaValidMesh() { - TetQuality *qt = new TetQuality(m) ; + auto qt = new TetQuality(m) ; qt->refresh(); int numNegElements = qt->nonPositive; delete qt; @@ -392,7 +392,7 @@ class TetrahedraReconnectUtility } //do interpolation - BinBasedFastPointLocator<3>::ResultIteratorType result_begin = results.begin(); + auto result_begin = results.begin(); Element::Pointer pelement; bool is_found = element_finder.FindPointOnMesh(pnode->Coordinates(), N, pelement, result_begin, max_results); @@ -513,7 +513,7 @@ class TetrahedraReconnectUtility EvaluateQuality(); setVertexExpectedSize(r_model_part , m); std::cout <<"...Start Optimization..." <<"\n"; - TVMWLoader* ml2 = new TVMWLoader(); + auto ml2 = new TVMWLoader(); std::string s(""); s = "../out_MeshFromKratos" + intToString(simIter)+".vwm"; @@ -672,12 +672,12 @@ class TetrahedraReconnectUtility /// Destroy the structure void FinalizeOptimization(bool removeFreeVertexes ) { - if (m == NULL ) return ; + if (m == nullptr ) return ; if (debugMode) std::cout <<"...Output to Kratos Format" <<"\n"; // Get back in Kratos innerConvertToKratos(refMP , m , removeFreeVertexes); delete m; - m = NULL; + m = nullptr; std::cout <<"...Trying to release memory\n"; clearPool(); std::cout <<"...Release memory OK\n"; diff --git a/applications/MeshingApplication/external_includes/tetgen_cdt.h b/applications/MeshingApplication/external_includes/tetgen_cdt.h index 78d216334cf4..faaddd89dc09 100644 --- a/applications/MeshingApplication/external_includes/tetgen_cdt.h +++ b/applications/MeshingApplication/external_includes/tetgen_cdt.h @@ -80,7 +80,7 @@ namespace Kratos {} /// Destructor. - virtual ~TetGenCDT() {} + virtual ~TetGenCDT() = default; ///@} @@ -306,7 +306,7 @@ namespace Kratos f->numberofpolygons = 1; f->polygonlist = new tetgenio::polygon[f->numberofpolygons]; f->numberofholes = 0; - f->holelist = NULL; + f->holelist = nullptr; Geometry >& geom = (it)->GetGeometry(); @@ -546,7 +546,7 @@ namespace Kratos } //do interpolation - BinBasedFastPointLocator<3>::ResultIteratorType result_begin = results.begin(); + auto result_begin = results.begin(); Element::Pointer pelement; bool is_found = element_finder.FindPointOnMesh(pnode->Coordinates(), N, pelement, result_begin, max_results); diff --git a/applications/MeshingApplication/external_includes/tetgen_pfem_contact.h b/applications/MeshingApplication/external_includes/tetgen_pfem_contact.h index 17bb93272378..73aa87b83ff7 100644 --- a/applications/MeshingApplication/external_includes/tetgen_pfem_contact.h +++ b/applications/MeshingApplication/external_includes/tetgen_pfem_contact.h @@ -76,10 +76,10 @@ class TetGenPfemContact ///@{ /// Default constructor. - TetGenPfemContact() {} + TetGenPfemContact() = default; /// Destructor. - virtual ~TetGenPfemContact() {} + virtual ~TetGenPfemContact() = default; ///@} @@ -168,7 +168,7 @@ class TetGenPfemContact f->numberofpolygons = 1; f->polygonlist = new tetgenio::polygon[f->numberofpolygons]; f->numberofholes = 0; - f->holelist = NULL; + f->holelist = nullptr; p = &f->polygonlist[0]; @@ -184,7 +184,7 @@ class TetGenPfemContact //holes in_shell.numberofholes = 0; - in_shell.holelist = NULL; + in_shell.holelist = nullptr; } //KRATOS_WATCH("@@@@@@@@@@@@@ before meshing @@@@@@@@@@@@@@@@"); diff --git a/applications/MeshingApplication/external_includes/tetgen_pfem_refine.h b/applications/MeshingApplication/external_includes/tetgen_pfem_refine.h index 8e040376fede..22233241f481 100644 --- a/applications/MeshingApplication/external_includes/tetgen_pfem_refine.h +++ b/applications/MeshingApplication/external_includes/tetgen_pfem_refine.h @@ -87,7 +87,7 @@ namespace Kratos mRhs(ZeroVector(3)){} //dimension = number of nodes /// Destructor. - virtual ~TetGenPfemModeler(){} + virtual ~TetGenPfemModeler()= default; ///@} @@ -689,7 +689,7 @@ namespace Kratos //KRATOS_WATCH(results.size()) - for(PointIterator it=results.begin(); it!=results.begin() + number_of_points_in_radius; it++) + for(auto it=results.begin(); it!=results.begin() + number_of_points_in_radius; it++) { bool is_inside=false; @@ -714,12 +714,12 @@ namespace Kratos ThisModelPart.Conditions().clear(); //set the coordinates to the original value - for( PointVector::iterator it = list_of_new_nodes.begin(); it!=list_of_new_nodes.end(); it++) + for(auto & list_of_new_node : list_of_new_nodes) { - const array_1d& disp = (*it)->FastGetSolutionStepValue(DISPLACEMENT); - (*it)->X0() = (*it)->X() - disp[0]; - (*it)->Y0() = (*it)->Y() - disp[1]; - (*it)->Z0() = (*it)->Z() - disp[2]; + const array_1d& disp = list_of_new_node->FastGetSolutionStepValue(DISPLACEMENT); + list_of_new_node->X0() = list_of_new_node->X() - disp[0]; + list_of_new_node->Y0() = list_of_new_node->Y() - disp[1]; + list_of_new_node->Z0() = list_of_new_node->Z() - disp[2]; } //cleaning unnecessary data in2.deinitialize(); diff --git a/applications/MeshingApplication/external_includes/tetgen_pfem_refine_face.h b/applications/MeshingApplication/external_includes/tetgen_pfem_refine_face.h index ce0677dfc44a..eeceac672fa9 100755 --- a/applications/MeshingApplication/external_includes/tetgen_pfem_refine_face.h +++ b/applications/MeshingApplication/external_includes/tetgen_pfem_refine_face.h @@ -83,7 +83,7 @@ class TetGenPfemRefineFace mRhs(ZeroVector(3)) {} //dimension = number of nodes /// Destructor. - virtual ~TetGenPfemRefineFace() {} + virtual ~TetGenPfemRefineFace() = default; ///@} @@ -219,7 +219,7 @@ class TetGenPfemRefineFace { double erased_nodes = 0; - for(PointIterator i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) + for(auto i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) erased_nodes += (*i)->Is(TO_ERASE); @@ -346,7 +346,7 @@ class TetGenPfemRefineFace f->numberofpolygons = 1; f->polygonlist = new tetgenio::polygon[f->numberofpolygons]; f->numberofholes = 0; - f->holelist = NULL; + f->holelist = nullptr; p = &f->polygonlist[0]; @@ -367,7 +367,7 @@ class TetGenPfemRefineFace //holes in.numberofholes = 0; - in.holelist = NULL; + in.holelist = nullptr; //regions in.numberofregions = 1; @@ -747,7 +747,7 @@ class TetGenPfemRefineFace //KRATOS_WATCH(results.size()) - for(PointIterator it=results.begin(); it!=results.begin() + number_of_points_in_radius; it++) + for(auto it=results.begin(); it!=results.begin() + number_of_points_in_radius; it++) { bool is_inside=false; // KRATOS_WATCH((*it)->Id()); @@ -781,14 +781,14 @@ class TetGenPfemRefineFace ThisModelPart.Conditions().clear(); //set the coordinates to the original value - for( PointVector::iterator it = list_of_new_nodes.begin(); it!=list_of_new_nodes.end(); it++) + for(auto & list_of_new_node : list_of_new_nodes) { - const array_1d& disp = (*it)->FastGetSolutionStepValue(DISPLACEMENT); - (*it)->X0() = (*it)->X() - disp[0]; - (*it)->Y0() = (*it)->Y() - disp[1]; - (*it)->Z0() = (*it)->Z() - disp[2]; + const array_1d& disp = list_of_new_node->FastGetSolutionStepValue(DISPLACEMENT); + list_of_new_node->X0() = list_of_new_node->X() - disp[0]; + list_of_new_node->Y0() = list_of_new_node->Y() - disp[1]; + list_of_new_node->Z0() = list_of_new_node->Z() - disp[2]; - if((*it)->FastGetSolutionStepValue(IS_WATER) != 0.0 && (*it)->FastGetSolutionStepValue(IS_WATER) != 1.0) + if(list_of_new_node->FastGetSolutionStepValue(IS_WATER) != 0.0 && list_of_new_node->FastGetSolutionStepValue(IS_WATER) != 1.0) KRATOS_WATCH("SSSSSSSSSSSSSSSSSSS a non_interpolated node SSSSSSSSSSSSSSSSSSSSS"); } //cleaning unnecessary data @@ -1661,7 +1661,7 @@ class TetGenPfemRefineFace f->numberofpolygons = 1; f->polygonlist = new tetgenio::polygon[f->numberofpolygons]; f->numberofholes = 0; - f->holelist = NULL; + f->holelist = nullptr; p = &f->polygonlist[0]; @@ -1677,7 +1677,7 @@ class TetGenPfemRefineFace //holes in_shell.numberofholes = 0; - in_shell.holelist = NULL; + in_shell.holelist = nullptr; } KRATOS_WATCH("Bofere mesh generation"); diff --git a/applications/MeshingApplication/external_includes/tetgen_pfem_refine_vms.h b/applications/MeshingApplication/external_includes/tetgen_pfem_refine_vms.h index 4f60c2139da7..ea063e7038cc 100644 --- a/applications/MeshingApplication/external_includes/tetgen_pfem_refine_vms.h +++ b/applications/MeshingApplication/external_includes/tetgen_pfem_refine_vms.h @@ -85,7 +85,7 @@ namespace Kratos mRhs(ZeroVector(3)){} //dimension = number of nodes /// Destructor. - virtual ~TetGenPfemModelerVms(){} + ~TetGenPfemModelerVms() override= default; ///@} @@ -192,7 +192,7 @@ namespace Kratos { //look if we are already erasing any of the other nodes double erased_nodes = 0; - for(PointIterator i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) + for(auto i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) erased_nodes += in->Is(TO_ERASE); if( erased_nodes < 1) //we cancel the node if no other nodes are being erased @@ -204,7 +204,7 @@ namespace Kratos //with IS_BOUNDARY=1 which are closer than 0.2*nodal_h from our we remove the node we are considering unsigned int k = 0; unsigned int counter = 0; - for(PointIterator i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) + for(auto i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) { if ( (*i)->FastGetSolutionStepValue(IS_BOUNDARY,1)==1.0 && res_distances[k] < 0.2*radius && res_distances[k] > 0.0 ) { @@ -714,7 +714,7 @@ namespace Kratos //KRATOS_WATCH(results.size()) - for(PointIterator it=results.begin(); it!=results.begin() + number_of_points_in_radius; it++) + for(auto it=results.begin(); it!=results.begin() + number_of_points_in_radius; it++) { bool is_inside=false; @@ -739,12 +739,12 @@ namespace Kratos ThisModelPart.Conditions().clear(); //set the coordinates to the original value - for( PointVector::iterator it = list_of_new_nodes.begin(); it!=list_of_new_nodes.end(); it++) + for(auto & list_of_new_node : list_of_new_nodes) { - const array_1d& disp = (*it)->FastGetSolutionStepValue(DISPLACEMENT); - (*it)->X0() = (*it)->X() - disp[0]; - (*it)->Y0() = (*it)->Y() - disp[1]; - (*it)->Z0() = (*it)->Z() - disp[2]; + const array_1d& disp = list_of_new_node->FastGetSolutionStepValue(DISPLACEMENT); + list_of_new_node->X0() = list_of_new_node->X() - disp[0]; + list_of_new_node->Y0() = list_of_new_node->Y() - disp[1]; + list_of_new_node->Z0() = list_of_new_node->Z() - disp[2]; } //cleaning unnecessary data in2.deinitialize(); @@ -919,13 +919,13 @@ ModelPart::NodesContainerType& ModelNodes = ThisModelPart.Nodes(); ///@{ /// Turn back information as a string. - virtual std::string Info() const{return "";} + std::string Info() const override{return "";} /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const{} + void PrintInfo(std::ostream& rOStream) const override{} /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const{} + void PrintData(std::ostream& rOStream) const override{} ///@} diff --git a/applications/MeshingApplication/external_includes/trigen_cdt.h b/applications/MeshingApplication/external_includes/trigen_cdt.h index e27306651278..67c021bec163 100644 --- a/applications/MeshingApplication/external_includes/trigen_cdt.h +++ b/applications/MeshingApplication/external_includes/trigen_cdt.h @@ -75,10 +75,10 @@ class TriGenCDT ///@{ /// Default constructor. - TriGenCDT() {} // + TriGenCDT() = default; // /// Destructor. - virtual ~TriGenCDT() {} + virtual ~TriGenCDT() = default; ///@} @@ -303,28 +303,28 @@ class TriGenCDT void clean_triangulateio( triangulateio& tr ) { - tr.pointlist = (REAL*) NULL; - tr.pointattributelist = (REAL*) NULL; - tr.pointmarkerlist = (int*) NULL; + tr.pointlist = (REAL*) nullptr; + tr.pointattributelist = (REAL*) nullptr; + tr.pointmarkerlist = (int*) nullptr; tr.numberofpoints = 0; tr.numberofpointattributes = 0; - tr.trianglelist = (int*) NULL; - tr.triangleattributelist = (REAL*) NULL; - tr.trianglearealist = (REAL*) NULL; - tr.neighborlist = (int*) NULL; + tr.trianglelist = (int*) nullptr; + tr.triangleattributelist = (REAL*) nullptr; + tr.trianglearealist = (REAL*) nullptr; + tr.neighborlist = (int*) nullptr; tr.numberoftriangles = 0; tr.numberofcorners = 3; tr.numberoftriangleattributes = 0; - tr.segmentlist = (int*) NULL; - tr.segmentmarkerlist = (int*) NULL; + tr.segmentlist = (int*) nullptr; + tr.segmentmarkerlist = (int*) nullptr; tr.numberofsegments = 0; - tr.holelist = (REAL*) NULL; + tr.holelist = (REAL*) nullptr; tr.numberofholes = 0; - tr.regionlist = (REAL*) NULL; + tr.regionlist = (REAL*) nullptr; tr.numberofregions = 0; - tr.edgelist = (int*) NULL; - tr.edgemarkerlist = (int*) NULL; - tr.normlist = (REAL*) NULL; + tr.edgelist = (int*) nullptr; + tr.edgemarkerlist = (int*) nullptr; + tr.normlist = (REAL*) nullptr; tr.numberofedges = 0; }; diff --git a/applications/MeshingApplication/external_includes/trigen_pfem_refine.h b/applications/MeshingApplication/external_includes/trigen_pfem_refine.h index b8abd6d7dde8..99496a557364 100644 --- a/applications/MeshingApplication/external_includes/trigen_pfem_refine.h +++ b/applications/MeshingApplication/external_includes/trigen_pfem_refine.h @@ -94,7 +94,7 @@ class TriGenPFEMModeler //mpNodeEraseProcess(NULL){} //dimension = number of nodes /// Destructor. - virtual ~TriGenPFEMModeler() {} + virtual ~TriGenPFEMModeler() = default; ///@} @@ -458,7 +458,7 @@ class TriGenPFEMModeler ); //check if inside and eventually interpolate - for( PointIterator it_found = Results.begin(); it_found != Results.begin() + number_of_points_in_radius; it_found++) + for( auto it_found = Results.begin(); it_found != Results.begin() + number_of_points_in_radius; it_found++) { bool is_inside = false; is_inside = CalculatePosition(x1[0], x1[1], @@ -479,12 +479,12 @@ class TriGenPFEMModeler ThisModelPart.Elements().clear(); //set the coordinates to the original value - for( PointVector::iterator it = list_of_new_nodes.begin(); it!=list_of_new_nodes.end(); it++) + for(auto & list_of_new_node : list_of_new_nodes) { - const array_1d& disp = (*it)->FastGetSolutionStepValue(DISPLACEMENT); - (*it)->X0() = (*it)->X() - disp[0]; - (*it)->Y0() = (*it)->Y() - disp[1]; - (*it)->Z0() = 0.0; + const array_1d& disp = list_of_new_node->FastGetSolutionStepValue(DISPLACEMENT); + list_of_new_node->X0() = list_of_new_node->X() - disp[0]; + list_of_new_node->Y0() = list_of_new_node->Y() - disp[1]; + list_of_new_node->Z0() = 0.0; } //cleaning unnecessary data //in2.deinitialize(); @@ -679,7 +679,7 @@ class TriGenPFEMModeler { //look if we are already erasing any of the other nodes double erased_nodes = 0; - for(PointIterator i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) + for(auto i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) erased_nodes += in->Is(TO_ERASE); if( erased_nodes < 1) //we cancel the node if no other nodes are being erased @@ -692,7 +692,7 @@ class TriGenPFEMModeler //with IS_BOUNDARY=1 which are closer than 0.2*nodal_h from our we remove the node we are considering unsigned int k = 0; unsigned int counter = 0; - for(PointIterator i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) + for(auto i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) { if ( (*i)->FastGetSolutionStepValue(IS_BOUNDARY,1)==1.0 && res_distances[k] < 0.2*radius && res_distances[k] > 0.0 ) { @@ -1120,47 +1120,47 @@ class TriGenPFEMModeler void initialize_triangulateio( triangulateio& tr ) { - tr.pointlist = (REAL*) NULL; - tr.pointattributelist = (REAL*) NULL; - tr.pointmarkerlist = (int*) NULL; + tr.pointlist = (REAL*) nullptr; + tr.pointattributelist = (REAL*) nullptr; + tr.pointmarkerlist = (int*) nullptr; tr.numberofpoints = 0; tr.numberofpointattributes = 0; - tr.trianglelist = (int*) NULL; - tr.triangleattributelist = (REAL*) NULL; - tr.trianglearealist = (REAL*) NULL; - tr.neighborlist = (int*) NULL; + tr.trianglelist = (int*) nullptr; + tr.triangleattributelist = (REAL*) nullptr; + tr.trianglearealist = (REAL*) nullptr; + tr.neighborlist = (int*) nullptr; tr.numberoftriangles = 0; tr.numberofcorners = 3; tr.numberoftriangleattributes = 0; - tr.segmentlist = (int*) NULL; - tr.segmentmarkerlist = (int*) NULL; + tr.segmentlist = (int*) nullptr; + tr.segmentmarkerlist = (int*) nullptr; tr.numberofsegments = 0; - tr.holelist = (REAL*) NULL; + tr.holelist = (REAL*) nullptr; tr.numberofholes = 0; - tr.regionlist = (REAL*) NULL; + tr.regionlist = (REAL*) nullptr; tr.numberofregions = 0; - tr.edgelist = (int*) NULL; - tr.edgemarkerlist = (int*) NULL; - tr.normlist = (REAL*) NULL; + tr.edgelist = (int*) nullptr; + tr.edgemarkerlist = (int*) nullptr; + tr.normlist = (REAL*) nullptr; tr.numberofedges = 0; }; void clean_triangulateio( triangulateio& tr ) { - if(tr.pointlist != NULL) free(tr.pointlist ); - if(tr.pointattributelist != NULL) free(tr.pointattributelist ); - if(tr.pointmarkerlist != NULL) free(tr.pointmarkerlist ); - if(tr.trianglelist != NULL) free(tr.trianglelist ); - if(tr.triangleattributelist != NULL) free(tr.triangleattributelist ); - if(tr.trianglearealist != NULL) free(tr.trianglearealist ); - if(tr.neighborlist != NULL) free(tr.neighborlist ); - if(tr.segmentlist != NULL) free(tr.segmentlist ); - if(tr.segmentmarkerlist != NULL) free(tr.segmentmarkerlist ); - if(tr.holelist != NULL) free(tr.holelist ); - if(tr.regionlist != NULL) free(tr.regionlist ); - if(tr.edgelist != NULL) free(tr.edgelist ); - if(tr.edgemarkerlist != NULL) free(tr.edgemarkerlist ); - if(tr.normlist != NULL) free(tr.normlist ); + if(tr.pointlist != nullptr) free(tr.pointlist ); + if(tr.pointattributelist != nullptr) free(tr.pointattributelist ); + if(tr.pointmarkerlist != nullptr) free(tr.pointmarkerlist ); + if(tr.trianglelist != nullptr) free(tr.trianglelist ); + if(tr.triangleattributelist != nullptr) free(tr.triangleattributelist ); + if(tr.trianglearealist != nullptr) free(tr.trianglearealist ); + if(tr.neighborlist != nullptr) free(tr.neighborlist ); + if(tr.segmentlist != nullptr) free(tr.segmentlist ); + if(tr.segmentmarkerlist != nullptr) free(tr.segmentmarkerlist ); + if(tr.holelist != nullptr) free(tr.holelist ); + if(tr.regionlist != nullptr) free(tr.regionlist ); + if(tr.edgelist != nullptr) free(tr.edgelist ); + if(tr.edgemarkerlist != nullptr) free(tr.edgemarkerlist ); + if(tr.normlist != nullptr) free(tr.normlist ); }; ///@} ///@name Private Operations diff --git a/applications/MeshingApplication/external_includes/trigen_pfem_refine_segment.h b/applications/MeshingApplication/external_includes/trigen_pfem_refine_segment.h index 954bfb7aa8ef..989640995fc1 100644 --- a/applications/MeshingApplication/external_includes/trigen_pfem_refine_segment.h +++ b/applications/MeshingApplication/external_includes/trigen_pfem_refine_segment.h @@ -88,7 +88,7 @@ class TriGenPFEMRefineSegment //mpNodeEraseProcess(NULL){} //dimension = number of nodes /// Destructor. - virtual ~TriGenPFEMRefineSegment() {} + virtual ~TriGenPFEMRefineSegment() = default; ///@} @@ -291,7 +291,7 @@ class TriGenPFEMRefineSegment { //look if we are already erasing any of the other nodes double erased_nodes = 0; - for(PointIterator i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) + for(auto i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) erased_nodes += (*i)->Is(TO_ERASE); /* @@ -315,7 +315,7 @@ class TriGenPFEMRefineSegment //with IS_BOUNDARY=1 which are closer than 0.2*nodal_h from our we remove the node we are considering unsigned int k = 0; unsigned int counter = 0; - for(PointIterator i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) + for(auto i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) { if ( (*i)->FastGetSolutionStepValue(IS_BOUNDARY,1)==1.0 && res_distances[k] < 0.2*radius && res_distances[k] > 0.0 ) { @@ -887,7 +887,7 @@ class TriGenPFEMRefineSegment ); //check if inside and eventually interpolate - for( PointIterator it_found = Results.begin(); it_found != Results.begin() + number_of_points_in_radius; it_found++) + for( auto it_found = Results.begin(); it_found != Results.begin() + number_of_points_in_radius; it_found++) { bool is_inside = false; is_inside = CalculatePosition(x1[0], x1[1], @@ -910,12 +910,12 @@ class TriGenPFEMRefineSegment ThisModelPart.Elements().clear(); //set the coordinates to the original value - for( PointVector::iterator it = list_of_new_nodes.begin(); it!=list_of_new_nodes.end(); it++) + for(auto & list_of_new_node : list_of_new_nodes) { - const array_1d& disp = (*it)->FastGetSolutionStepValue(DISPLACEMENT); - (*it)->X0() = (*it)->X() - disp[0]; - (*it)->Y0() = (*it)->Y() - disp[1]; - (*it)->Z0() = 0.0; + const array_1d& disp = list_of_new_node->FastGetSolutionStepValue(DISPLACEMENT); + list_of_new_node->X0() = list_of_new_node->X() - disp[0]; + list_of_new_node->Y0() = list_of_new_node->Y() - disp[1]; + list_of_new_node->Z0() = 0.0; } //cleaning unnecessary data //in2.deinitialize(); @@ -1609,12 +1609,12 @@ class TriGenPFEMRefineSegment KRATOS_WATCH(ThisModelPart.Nodes()[bad_node].Y()); //ens of COORDINTAES - for(unsigned int jj=0; jj& disp = (*it)->FastGetSolutionStepValue(DISPLACEMENT); - (*it)->X0() = (*it)->X() - disp[0]; - (*it)->Y0() = (*it)->Y() - disp[1]; - (*it)->Z0() = 0.0; + const array_1d& disp = list_of_new_node->FastGetSolutionStepValue(DISPLACEMENT); + list_of_new_node->X0() = list_of_new_node->X() - disp[0]; + list_of_new_node->Y0() = list_of_new_node->Y() - disp[1]; + list_of_new_node->Z0() = 0.0; } //cleaning unnecessary data //in2.deinitialize(); @@ -575,16 +575,16 @@ class TriGenPFEMModelerVMS : public TriGenPFEMModeler ///@{ /// Turn back information as a string. - virtual std::string Info() const + std::string Info() const override { return ""; } /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const {} + void PrintInfo(std::ostream& rOStream) const override {} /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const {} + void PrintData(std::ostream& rOStream) const override {} ///@} @@ -680,7 +680,7 @@ class TriGenPFEMModelerVMS : public TriGenPFEMModeler { //look if we are already erasing any of the other nodes double erased_nodes = 0; - for(PointIterator i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) + for(auto i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) erased_nodes += in->Is(TO_ERASE); if( erased_nodes < 1) //we cancel the node if no other nodes are being erased @@ -693,7 +693,7 @@ class TriGenPFEMModelerVMS : public TriGenPFEMModeler //with IS_BOUNDARY=1 which are closer than 0.2*nodal_h from our we remove the node we are considering unsigned int k = 0; unsigned int counter = 0; - for(PointIterator i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) + for(auto i=res.begin(); i!=res.begin() + n_points_in_radius ; i++) { if ( (*i)->FastGetSolutionStepValue(IS_BOUNDARY,1)==1.0 && res_distances[k] < 0.2*radius && res_distances[k] > 0.0 ) { @@ -1157,47 +1157,47 @@ class TriGenPFEMModelerVMS : public TriGenPFEMModeler void initialize_triangulateio( triangulateio& tr ) { - tr.pointlist = (REAL*) NULL; - tr.pointattributelist = (REAL*) NULL; - tr.pointmarkerlist = (int*) NULL; + tr.pointlist = (REAL*) nullptr; + tr.pointattributelist = (REAL*) nullptr; + tr.pointmarkerlist = (int*) nullptr; tr.numberofpoints = 0; tr.numberofpointattributes = 0; - tr.trianglelist = (int*) NULL; - tr.triangleattributelist = (REAL*) NULL; - tr.trianglearealist = (REAL*) NULL; - tr.neighborlist = (int*) NULL; + tr.trianglelist = (int*) nullptr; + tr.triangleattributelist = (REAL*) nullptr; + tr.trianglearealist = (REAL*) nullptr; + tr.neighborlist = (int*) nullptr; tr.numberoftriangles = 0; tr.numberofcorners = 3; tr.numberoftriangleattributes = 0; - tr.segmentlist = (int*) NULL; - tr.segmentmarkerlist = (int*) NULL; + tr.segmentlist = (int*) nullptr; + tr.segmentmarkerlist = (int*) nullptr; tr.numberofsegments = 0; - tr.holelist = (REAL*) NULL; + tr.holelist = (REAL*) nullptr; tr.numberofholes = 0; - tr.regionlist = (REAL*) NULL; + tr.regionlist = (REAL*) nullptr; tr.numberofregions = 0; - tr.edgelist = (int*) NULL; - tr.edgemarkerlist = (int*) NULL; - tr.normlist = (REAL*) NULL; + tr.edgelist = (int*) nullptr; + tr.edgemarkerlist = (int*) nullptr; + tr.normlist = (REAL*) nullptr; tr.numberofedges = 0; }; void clean_triangulateio( triangulateio& tr ) { - if(tr.pointlist != NULL) free(tr.pointlist ); - if(tr.pointattributelist != NULL) free(tr.pointattributelist ); - if(tr.pointmarkerlist != NULL) free(tr.pointmarkerlist ); - if(tr.trianglelist != NULL) free(tr.trianglelist ); - if(tr.triangleattributelist != NULL) free(tr.triangleattributelist ); - if(tr.trianglearealist != NULL) free(tr.trianglearealist ); - if(tr.neighborlist != NULL) free(tr.neighborlist ); - if(tr.segmentlist != NULL) free(tr.segmentlist ); - if(tr.segmentmarkerlist != NULL) free(tr.segmentmarkerlist ); - if(tr.holelist != NULL) free(tr.holelist ); - if(tr.regionlist != NULL) free(tr.regionlist ); - if(tr.edgelist != NULL) free(tr.edgelist ); - if(tr.edgemarkerlist != NULL) free(tr.edgemarkerlist ); - if(tr.normlist != NULL) free(tr.normlist ); + if(tr.pointlist != nullptr) free(tr.pointlist ); + if(tr.pointattributelist != nullptr) free(tr.pointattributelist ); + if(tr.pointmarkerlist != nullptr) free(tr.pointmarkerlist ); + if(tr.trianglelist != nullptr) free(tr.trianglelist ); + if(tr.triangleattributelist != nullptr) free(tr.triangleattributelist ); + if(tr.trianglearealist != nullptr) free(tr.trianglearealist ); + if(tr.neighborlist != nullptr) free(tr.neighborlist ); + if(tr.segmentlist != nullptr) free(tr.segmentlist ); + if(tr.segmentmarkerlist != nullptr) free(tr.segmentmarkerlist ); + if(tr.holelist != nullptr) free(tr.holelist ); + if(tr.regionlist != nullptr) free(tr.regionlist ); + if(tr.edgelist != nullptr) free(tr.edgelist ); + if(tr.edgemarkerlist != nullptr) free(tr.edgemarkerlist ); + if(tr.normlist != nullptr) free(tr.normlist ); }; ///@} ///@name Private Operations diff --git a/applications/MeshingApplication/meshing_application.cpp b/applications/MeshingApplication/meshing_application.cpp index bc74b790f3c2..bde019ae3567 100644 --- a/applications/MeshingApplication/meshing_application.cpp +++ b/applications/MeshingApplication/meshing_application.cpp @@ -10,6 +10,7 @@ // Main authors: Nelson Lafontaine // Jordi Cotela Dalmau // Riccardo Rossi +// Vicente Mataix Ferrándiz // // System includes @@ -35,10 +36,11 @@ typedef array_1d Vector3; //KRATOS_CREATE_VARIABLE( double, WEIGHT_FATHER_NODES ) //KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(PRESSURE_FORCE) //KRATOS_CREATE_VARIABLE(double, COUNTER) //already put on variables.cpp (warning was appearing on Windows) -KRATOS_CREATE_VARIABLE(double, ANISOTROPIC_RATIO); -KRATOS_CREATE_VARIABLE(Vector3, AUXILIAR_GRADIENT); -KRATOS_CREATE_VARIABLE(Vector, AUXILIAR_HESSIAN); -KRATOS_CREATE_VARIABLE(Vector, MMG_METRIC); +KRATOS_CREATE_VARIABLE(double, AVERAGE_NODAL_ERROR); // The average nodal error +KRATOS_CREATE_VARIABLE(double, ANISOTROPIC_RATIO); // The anisotropic aspect ratio +KRATOS_CREATE_VARIABLE(Vector3, AUXILIAR_GRADIENT); // An auxiliar gradient needed to compute the metric +KRATOS_CREATE_VARIABLE(Vector, AUXILIAR_HESSIAN); // An auxiliar hessian needed to compute the metric +KRATOS_CREATE_VARIABLE(Vector, MMG_METRIC); // The condensed metric used to remesh with MMG utility KratosMeshingApplication::KratosMeshingApplication(): mTestElement2D(0, Element::GeometryType::Pointer(new Triangle2D3 >(Element::GeometryType::PointsArrayType(3)))), @@ -53,10 +55,11 @@ void KratosMeshingApplication::Register() std::cout << "Initializing Kratos MeshingApplication... " << std::endl; //KRATOS_REGISTER_VARIABLE(COUNTER); //already put on variables.cpp (warning was appearing on Windows) - KRATOS_REGISTER_VARIABLE(ANISOTROPIC_RATIO); - KRATOS_REGISTER_VARIABLE(AUXILIAR_GRADIENT); - KRATOS_REGISTER_VARIABLE(AUXILIAR_HESSIAN); - KRATOS_REGISTER_VARIABLE(MMG_METRIC); + KRATOS_REGISTER_VARIABLE(AVERAGE_NODAL_ERROR); // The average nodal error + KRATOS_REGISTER_VARIABLE(ANISOTROPIC_RATIO); // The anisotropic aspect ratio + KRATOS_REGISTER_VARIABLE(AUXILIAR_GRADIENT); // An auxiliar gradient needed to compute the metric + KRATOS_REGISTER_VARIABLE(AUXILIAR_HESSIAN); // An auxiliar hessian needed to compute the metric + KRATOS_REGISTER_VARIABLE(MMG_METRIC); // The condensed metric used to remesh with MMG utility KRATOS_REGISTER_ELEMENT("TestElement2D", mTestElement2D); KRATOS_REGISTER_ELEMENT("TestElement3D", mTestElement3D); diff --git a/applications/MeshingApplication/meshing_application.h b/applications/MeshingApplication/meshing_application.h index 51a8132161b2..30b6644ec009 100644 --- a/applications/MeshingApplication/meshing_application.h +++ b/applications/MeshingApplication/meshing_application.h @@ -10,6 +10,7 @@ // Main authors: Nelson Lafontaine // Jordi Cotela Dalmau // Riccardo Rossi +// Vicente Mataix Ferrándiz // #if !defined(KRATOS_KRATOS_MESHING_APPLICATION_H_INCLUDED ) @@ -44,11 +45,12 @@ typedef array_1d Vector3; // Variables definition //KRATOS_DEFINE_VARIABLE(double, WEIGHT_FATHER_NODES ) // Moved to variables.h so trilinos application can use it too -//KRATOS_DEFINE_VARIABLE(double, COUNTER) //already put on variables.h (warning was appearing on Windows) -KRATOS_DEFINE_VARIABLE(double, ANISOTROPIC_RATIO); -KRATOS_DEFINE_VARIABLE(Vector3, AUXILIAR_GRADIENT); -KRATOS_DEFINE_VARIABLE(Vector, AUXILIAR_HESSIAN); -KRATOS_DEFINE_VARIABLE(Vector, MMG_METRIC); +// KRATOS_DEFINE_VARIABLE(double, COUNTER) // Already put on variables.h (warning was appearing on Windows) +KRATOS_DEFINE_VARIABLE(double, AVERAGE_NODAL_ERROR); // The average nodal error +KRATOS_DEFINE_VARIABLE(double, ANISOTROPIC_RATIO); // The anisotropic aspect ratio +KRATOS_DEFINE_VARIABLE(Vector3, AUXILIAR_GRADIENT); // An auxiliar gradient needed to compute the metric +KRATOS_DEFINE_VARIABLE(Vector, AUXILIAR_HESSIAN); // An auxiliar hessian needed to compute the metric +KRATOS_DEFINE_VARIABLE(Vector, MMG_METRIC); // The condensed metric used to remesh with MMG utility ///@} ///@name Type Definitions ///@{ @@ -86,7 +88,7 @@ class KratosMeshingApplication : public KratosApplication KratosMeshingApplication(); /// Destructor. - virtual ~KratosMeshingApplication() {} + ~KratosMeshingApplication() override = default; ///@} @@ -98,7 +100,7 @@ class KratosMeshingApplication : public KratosApplication ///@name Operations ///@{ - virtual void Register(); + void Register() override; @@ -117,20 +119,20 @@ class KratosMeshingApplication : public KratosApplication ///@{ /// Turn back information as a string. - virtual std::string Info() const + std::string Info() const override { return "KratosMeshingApplication"; } /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const + void PrintInfo(std::ostream& rOStream) const override { rOStream << Info(); PrintData(rOStream); } ///// Print object's data. - virtual void PrintData(std::ostream& rOStream) const + void PrintData(std::ostream& rOStream) const override { KRATOS_WATCH("in KratosMeshingApplication"); KRATOS_WATCH(KratosComponents::GetComponents().size() ); diff --git a/applications/MeshingApplication/python_scripts/mmg_process.py b/applications/MeshingApplication/python_scripts/mmg_process.py index e5d0398724fc..ae6a4a4a2209 100644 --- a/applications/MeshingApplication/python_scripts/mmg_process.py +++ b/applications/MeshingApplication/python_scripts/mmg_process.py @@ -157,10 +157,17 @@ def ExecuteInitialize(self): self._CreateMetricsProcess() + mmg_parameters = KratosMultiphysics.Parameters("""{}""") + mmg_parameters.AddValue("filename",self.params["filename"]) + mmg_parameters.AddValue("framework",self.params["framework"]) + mmg_parameters.AddValue("internal_variables_parameters",self.params["internal_variables_parameters"]) + mmg_parameters.AddValue("save_external_files",self.params["save_external_files"]) + mmg_parameters.AddValue("max_number_of_searchs",self.params["max_number_of_searchs"]) + mmg_parameters.AddValue("echo_level",self.params["echo_level"]) if (self.dim == 2): - self.MmgUtility = MeshingApplication.MmgUtility2D(self.Model[self.model_part_name], self.params) + self.MmgProcess = MeshingApplication.MmgProcess2D(self.Model[self.model_part_name], mmg_parameters) else: - self.MmgUtility = MeshingApplication.MmgUtility3D(self.Model[self.model_part_name], self.params) + self.MmgProcess = MeshingApplication.MmgProcess3D(self.Model[self.model_part_name], mmg_parameters) if (self.initial_remeshing == True): self._ExecuteRefinement() @@ -269,7 +276,7 @@ def _ExecuteRefinement(self): metric_process.Execute() print("Remeshing") - self.MmgUtility.RemeshModelPart() + self.MmgProcess.Execute() if (self.strategy == "LevelSet"): self.local_gradient.Execute() # Recalculate gradient after remeshing diff --git a/applications/MeshingApplication/tests/Kratos_Execute_Meshing_Test.py b/applications/MeshingApplication/tests/Kratos_Execute_Meshing_Test.py index edc547cffd66..859d16a833a0 100644 --- a/applications/MeshingApplication/tests/Kratos_Execute_Meshing_Test.py +++ b/applications/MeshingApplication/tests/Kratos_Execute_Meshing_Test.py @@ -1,10 +1,17 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -from KratosMultiphysics import * -from KratosMultiphysics.ExternalSolversApplication import * -from KratosMultiphysics.FluidDynamicsApplication import * -from KratosMultiphysics.SolidMechanicsApplication import * -from KratosMultiphysics.MeshingApplication import * +import KratosMultiphysics +import KratosMultiphysics.MeshingApplication as MeshingApplication +try: + import KratosMultiphysics.FluidDynamicsApplication as FluidDynamicsApplication + missing_external_fluid_dependencies = False +except ImportError as e: + missing_external_fluid_dependencies = True +try: + import KratosMultiphysics.StructuralMechanicsApplication as StructuralMechanicsApplication + missing_external_solid_dependencies = False +except ImportError as e: + missing_external_solid_dependencies = True import os import process_factory @@ -15,8 +22,8 @@ def __init__(self, ProjectParameters): self.ProjectParameters = ProjectParameters - self.main_model_part = ModelPart(self.ProjectParameters["problem_data"]["model_part_name"].GetString()) - self.main_model_part.ProcessInfo.SetValue(DOMAIN_SIZE, self.ProjectParameters["problem_data"]["domain_size"].GetInt()) + self.main_model_part = KratosMultiphysics.ModelPart(self.ProjectParameters["problem_data"]["model_part_name"].GetString()) + self.main_model_part.ProcessInfo.SetValue(KratosMultiphysics.DOMAIN_SIZE, self.ProjectParameters["problem_data"]["domain_size"].GetInt()) self.Model = {self.ProjectParameters["problem_data"]["model_part_name"].GetString(): self.main_model_part} @@ -24,25 +31,23 @@ def __init__(self, ProjectParameters): self.solve_problem = self.ProjectParameters["problem_data"]["solve_problem"].GetBool() - if self.problem_type == "fluid": + if (self.problem_type == "fluid" and missing_external_fluid_dependencies == False): ## Solver construction - import python_solvers_wrapper_fluid - self.solver = python_solvers_wrapper_fluid.CreateSolver(self.main_model_part, self.ProjectParameters) - elif self.problem_type == "solid": + import python_solvers_wrapper_fluid as fluid_wrapper + self.solver = fluid_wrapper.CreateSolver(self.main_model_part, self.ProjectParameters) + elif (self.problem_type == "solid" and missing_external_solid_dependencies == False): # Construct the solver (main setting methods are located in the solver_module) solver_module = __import__(self.ProjectParameters["solver_settings"]["solver_type"].GetString()) self.solver = solver_module.CreateSolver(self.main_model_part, self.ProjectParameters["solver_settings"]) + else: + raise NameError('Problem type not defined or failing in the import') # Add variables (always before importing the model part) (it must be integrated in the ImportModelPart) # If we integrate it in the model part we cannot use combined solvers self.solver.AddVariables() - self.main_model_part.AddNodalSolutionStepVariable(NODAL_H) - self.main_model_part.AddNodalSolutionStepVariable(NODAL_AREA) - self.main_model_part.AddNodalSolutionStepVariable(AUXILIAR_GRADIENT) - self.main_model_part.AddNodalSolutionStepVariable(AUXILIAR_HESSIAN) - self.main_model_part.AddNodalSolutionStepVariable(ANISOTROPIC_RATIO) - self.main_model_part.AddNodalSolutionStepVariable(MMG_METRIC) + self.main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.NODAL_H) + self.main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.NODAL_AREA) # Read model_part (note: the buffer_size is set here) (restart can be read here) self.solver.ImportModelPart() @@ -148,7 +153,7 @@ def Solve(self): # Delta time delta_time = self.ProjectParameters["problem_data"]["time_step"].GetDouble() # Start step - self.main_model_part.ProcessInfo[TIME_STEPS] = 0 + self.main_model_part.ProcessInfo[KratosMultiphysics.TIME_STEPS] = 0 # Start time time = self.ProjectParameters["problem_data"]["start_time"].GetDouble() # End time @@ -163,7 +168,7 @@ def Solve(self): # Solving the problem (time integration) while(time <= end_time): time = time + delta_time - self.main_model_part.ProcessInfo[TIME_STEPS] += 1 + self.main_model_part.ProcessInfo[KratosMultiphysics.TIME_STEPS] += 1 self.main_model_part.CloneTimeStep(time) step = step + 1 @@ -171,7 +176,7 @@ def Solve(self): for process in self.list_of_processes: process.ExecuteInitializeSolutionStep() - if (self.main_model_part.Is(MODIFIED) == True): + if (self.main_model_part.Is(KratosMultiphysics.MODIFIED) == True): # WE INITIALIZE THE SOLVER self.solver.Initialize() # WE RECOMPUTE THE PROCESSES AGAIN diff --git a/applications/MeshingApplication/tests/NightlyTests.py b/applications/MeshingApplication/tests/NightlyTests.py index 5433987e6bcd..8eaeed48729d 100644 --- a/applications/MeshingApplication/tests/NightlyTests.py +++ b/applications/MeshingApplication/tests/NightlyTests.py @@ -45,4 +45,4 @@ def tearDown(self): pass class StanfordBunnyTest(MeshingTestFactory): - file_name = "mmg_test/bunny_test" + file_name = "mmg_eulerian_test/bunny_test" diff --git a/applications/MeshingApplication/tests/SmallTests.py b/applications/MeshingApplication/tests/SmallTests.py index bc6512cf4e61..9b3667cccaf4 100644 --- a/applications/MeshingApplication/tests/SmallTests.py +++ b/applications/MeshingApplication/tests/SmallTests.py @@ -57,9 +57,6 @@ class ThreeDHessianTest(MeshingTestFactory): class TwoDCavityTest(MeshingTestFactory): file_name = "mmg_eulerian_test/2D_cavity_test" -class CoarseSphereTest(MeshingTestFactory): - file_name = "mmg_eulerian_test/coarse_sphere_test" - class TwoDDynamicBeamTest(MeshingTestFactory): file_name = "mmg_lagrangian_test/beam2D_test" diff --git a/applications/MeshingApplication/tests/ValidationTests.py b/applications/MeshingApplication/tests/ValidationTests.py index 7fe8c6588125..23e6d62f66f3 100644 --- a/applications/MeshingApplication/tests/ValidationTests.py +++ b/applications/MeshingApplication/tests/ValidationTests.py @@ -45,7 +45,7 @@ def tearDown(self): pass class TwoDSphereRemeshedChannelTest(MeshingTestFactory): - file_name = "mmg_test/2D_sphere_remeshed_channel_test" + file_name = "mmg_eulerian_test/2D_sphere_remeshed_channel_test" class ThreeDSphereRemeshedChannelTest(MeshingTestFactory): - file_name = "mmg_test/3D_sphere_remeshed_channel_test" + file_name = "mmg_eulerian_test/3D_sphere_remeshed_channel_test" diff --git a/applications/MeshingApplication/tests/materials.py b/applications/MeshingApplication/tests/materials.py deleted file mode 100755 index 2a05f3f1df90..000000000000 --- a/applications/MeshingApplication/tests/materials.py +++ /dev/null @@ -1,22 +0,0 @@ - -# Importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.SolidMechanicsApplication import * -#from beam_sections_python_utility import SetProperties -def AssignMaterial(Properties): - prop_id = 1; - prop = Properties[prop_id] - mat = LinearElasticPlaneStrain2DLaw() - prop.SetValue(CONSTITUTIVE_LAW, mat.Clone()) - - prop_id = 2; - prop = Properties[prop_id] - mat = LinearElastic3DLaw(); - prop.SetValue(CONSTITUTIVE_LAW, mat.Clone()); - - prop_id = 3; - prop = Properties[prop_id] - mat = HyperElasticPlasticJ2PlaneStrain2DLaw() - prop.SetValue(CONSTITUTIVE_LAW, mat.Clone()) - - print( prop ) diff --git a/applications/MeshingApplication/tests/mmg_eulerian_test/2D_cavity_test_parameters.json b/applications/MeshingApplication/tests/mmg_eulerian_test/2D_cavity_test_parameters.json index 578afc7e26ca..92d3be666431 100755 --- a/applications/MeshingApplication/tests/mmg_eulerian_test/2D_cavity_test_parameters.json +++ b/applications/MeshingApplication/tests/mmg_eulerian_test/2D_cavity_test_parameters.json @@ -26,7 +26,8 @@ "node_output" : false, "skin_output" : false, "plane_output" : [], - "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE","DISTANCE_GRADIENT","ANISOTROPIC_RATIO"], + "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE","DISTANCE_GRADIENT"], + "nodal_nonhistorical_results" : ["ANISOTROPIC_RATIO"], "gauss_point_results" : [] }, "point_data_configuration" : [] diff --git a/applications/MeshingApplication/tests/mmg_eulerian_test/2D_hessian_test_parameters.json b/applications/MeshingApplication/tests/mmg_eulerian_test/2D_hessian_test_parameters.json index 60a64a87d04b..384e079e0ecd 100755 --- a/applications/MeshingApplication/tests/mmg_eulerian_test/2D_hessian_test_parameters.json +++ b/applications/MeshingApplication/tests/mmg_eulerian_test/2D_hessian_test_parameters.json @@ -26,7 +26,8 @@ "node_output" : false, "skin_output" : false, "plane_output" : [], - "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE","ANISOTROPIC_RATIO"], + "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE"], + "nodal_nonhistorical_results" : ["ANISOTROPIC_RATIO"], "gauss_point_results" : [] }, "point_data_configuration" : [] diff --git a/applications/MeshingApplication/tests/mmg_eulerian_test/2D_sphere_remeshed_channel_test_parameters.json b/applications/MeshingApplication/tests/mmg_eulerian_test/2D_sphere_remeshed_channel_test_parameters.json index ffa09bda5d52..928f6e8d9e0e 100644 --- a/applications/MeshingApplication/tests/mmg_eulerian_test/2D_sphere_remeshed_channel_test_parameters.json +++ b/applications/MeshingApplication/tests/mmg_eulerian_test/2D_sphere_remeshed_channel_test_parameters.json @@ -27,7 +27,8 @@ "skin_output" : false, "plane_output" : [], "nodal_flags_results" : [], - "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE","ANISOTROPIC_RATIO"], + "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE"], + "nodal_nonhistorical_results" : ["ANISOTROPIC_RATIO"], "gauss_point_results" : [] }, "point_data_configuration" : [] diff --git a/applications/MeshingApplication/tests/mmg_eulerian_test/3D_hessian_test_parameters.json b/applications/MeshingApplication/tests/mmg_eulerian_test/3D_hessian_test_parameters.json index 7770254dc940..fea01818c795 100755 --- a/applications/MeshingApplication/tests/mmg_eulerian_test/3D_hessian_test_parameters.json +++ b/applications/MeshingApplication/tests/mmg_eulerian_test/3D_hessian_test_parameters.json @@ -26,7 +26,8 @@ "node_output" : false, "skin_output" : false, "plane_output" : [], - "nodal_results" : ["DISTANCE","ANISOTROPIC_RATIO"], + "nodal_results" : ["DISTANCE"], + "nodal_nonhistorical_results" : ["ANISOTROPIC_RATIO"], "gauss_point_results" : [] }, "point_data_configuration" : [] diff --git a/applications/MeshingApplication/tests/mmg_eulerian_test/3D_sphere_remeshed_channel_test_parameters.json b/applications/MeshingApplication/tests/mmg_eulerian_test/3D_sphere_remeshed_channel_test_parameters.json index 81f4347f821e..a81e6946bff6 100644 --- a/applications/MeshingApplication/tests/mmg_eulerian_test/3D_sphere_remeshed_channel_test_parameters.json +++ b/applications/MeshingApplication/tests/mmg_eulerian_test/3D_sphere_remeshed_channel_test_parameters.json @@ -26,7 +26,8 @@ "node_output" : false, "skin_output" : false, "plane_output" : [], - "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE","ANISOTROPIC_RATIO"], + "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE"], + "nodal_nonhistorical_results" : ["ANISOTROPIC_RATIO"], "gauss_point_results" : [] }, "point_data_configuration" : [] diff --git a/applications/MeshingApplication/tests/mmg_eulerian_test/bunny_test_parameters.json b/applications/MeshingApplication/tests/mmg_eulerian_test/bunny_test_parameters.json index 02f9580b868a..4c2d60888851 100755 --- a/applications/MeshingApplication/tests/mmg_eulerian_test/bunny_test_parameters.json +++ b/applications/MeshingApplication/tests/mmg_eulerian_test/bunny_test_parameters.json @@ -25,7 +25,8 @@ "node_output" : true, "skin_output" : false, "plane_output" : [], - "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE","DISTANCE_GRADIENT","ANISOTROPIC_RATIO"], + "nodal_results" : ["VELOCITY","PRESSURE","DISTANCE","DISTANCE_GRADIENT"], + "nodal_nonhistorical_results" : ["ANISOTROPIC_RATIO"], "gauss_point_results" : [] }, "point_data_configuration" : [] diff --git a/applications/MeshingApplication/tests/mmg_eulerian_test/coarse_sphere_test_parameters.json b/applications/MeshingApplication/tests/mmg_eulerian_test/coarse_sphere_test_parameters.json deleted file mode 100755 index e73b0ca88062..000000000000 --- a/applications/MeshingApplication/tests/mmg_eulerian_test/coarse_sphere_test_parameters.json +++ /dev/null @@ -1,129 +0,0 @@ -{ - "problem_data" : { - "problem_name" : "coarse_sphere_test", - "model_part_name" : "MainModelPart", - "problem_type" : "fluid", - "solve_problem" : false, - "domain_size" : 3, - "echo_level" : 0, - "parallel_type" : "OpenMP", - "start_time" : 0.0, - "end_time" : 0.03, - "time_step" : 0.011 - }, - "_output_configuration" : { - "result_file_configuration" : { - "gidpost_flags" : { - "GiDPostMode" : "GiD_PostBinary", - "WriteDeformedMeshFlag" : "WriteDeformed", - "WriteConditionsFlag" : "WriteConditions", - "MultiFileFlag" : "SingleFile" - }, - "file_label" : "step", - "output_control_type" : "step", - "output_frequency" : 1.0, - "body_output" : true, - "node_output" : false, - "skin_output" : false, - "plane_output" : [], - "nodal_results" : ["DISTANCE","DISTANCE_GRADIENT","ANISOTROPIC_RATIO"], - "gauss_point_results" : [] - }, - "point_data_configuration" : [] - }, - "restart_options" : { - "SaveRestart" : "False", - "RestartFrequency" : 0, - "LoadRestart" : "False", - "Restart_Step" : 0 - }, - "solver_settings" : { - "solver_type" : "Embedded", - "model_import_settings" : { - "input_type" : "mdpa", - "input_filename" : "mmg_eulerian_test/coarse_sphere_test" - }, - "maximum_iterations" : 10, - "echo_level" : 0, - "time_order" : 2, - "dynamic_tau" : 0.01, - "compute_reactions" : false, - "divergence_clearance_steps" : 0, - "reform_dofs_at_each_step" : false, - "relative_velocity_tolerance" : 0.001, - "absolute_velocity_tolerance" : 1e-5, - "relative_pressure_tolerance" : 0.001, - "absolute_pressure_tolerance" : 1e-5, - "volume_model_part_name" : "Parts_Parts_Auto1", - "skin_parts" : [], - "no_skin_parts" : [], - "linear_solver_settings" : { - "solver_type" : "AMGCL", - "max_iteration" : 200, - "tolerance" : 1e-7, - "provide_coordinates" : false, - "smoother_type" : "ilu0", - "krylov_type" : "gmres", - "coarsening_type" : "aggregation", - "scaling" : false - }, - "distance_reading_settings" : { - "import_mode" : "from_mdpa" - } - }, - "initial_conditions_process_list" : [], - "boundary_conditions_process_list" : [], - "gravity" : [{ - "python_module" : "process_factory", - "kratos_module" : "KratosMultiphysics", - "process_name" : "ApplyConstantVectorValueProcess", - "Parameters" : { - "mesh_id" : 0, - "model_part_name" : "Parts_Parts_Auto1", - "variable_name" : "BODY_FORCE", - "modulus" : 0.0, - "direction" : [0.0,-1.0,0.0] - } - }], - "initial_remeshing_process" :[ - { - "python_module" : "mmg_process", - "kratos_module" : "KratosMultiphysics", - "help" : "This process automatically remesh using MMG library", - "process_name" : "MmgProcess", - "Parameters" : { - "model_part_name" : "MainModelPart", - "filename" : "mmg_eulerian_test/coarse_sphere_test", - "minimal_size" : 1.0e-2, - "anisotropy_remeshing" : true, - "anisotropy_parameters" :{ - "hmin_over_hmax_anisotropic_ratio" : 0.15, - "boundary_layer_max_distance" : 1.0e-4, - "interpolation" : "Linear" - }, - "automatic_remesh" : true, - "automatic_remesh_parameters" :{ - "automatic_remesh_type" : "Percentage", - "min_size_ratio" : 0.25, - "min_size_current_percentage" : 0.5, - "refer_type" : "Mean" - }, - "save_external_files" : true, - "echo_level" : 0 - } - } - ], - "compare_two_files_check_process" :[ - { - "python_module" : "compare_two_files_check_process", - "kratos_module" : "KratosMultiphysics", - "help" : "This process compares two files and executes an Unittest Assert", - "process_name" : "CompareTwoFilesCheckProcess", - "Parameters" : { - "file_name_1" : "mmg_eulerian_test/coarse_sphere_test.o.mesh", - "file_name_2" : "mmg_eulerian_test/coarse_sphere_test_result.mesh", - "deterministic" : false - } - } - ] -} diff --git a/applications/MeshingApplication/tests/mmg_eulerian_test/coarse_sphere_test_result.mesh b/applications/MeshingApplication/tests/mmg_eulerian_test/coarse_sphere_test_result.mesh index 0e9a569a885f..0eef61528cff 100644 --- a/applications/MeshingApplication/tests/mmg_eulerian_test/coarse_sphere_test_result.mesh +++ b/applications/MeshingApplication/tests/mmg_eulerian_test/coarse_sphere_test_result.mesh @@ -5,12170 +5,7210 @@ Dimension 3 Vertices -1957 -0.176684473886819 0.180221872590623 -0.430473121090253 3 --0.00543618288206499 0.159666419426736 -0.473822727149532 3 -0.0296707919083137 0.134467829637986 -0.303272065713743 3 -0.00147881612895584 0.290846434433837 -0.406641393630668 3 --0.00402379525977115 -0.00896061069051057 -0.49992659183299 3 -0.340981867822558 -0.00126795428051008 -0.365530131970411 3 -0.275853836645268 0.361809467115166 -0.207263872493223 3 -0.00182628311642674 0.404118949437249 -0.294164576891006 3 -0.218344527751533 -0.0808146934956057 -0.251185837514764 3 --0.174067837492593 0.19536380065567 -0.425211069323494 3 -0.183644742149661 -0.174213315230886 -0.42965616430101 3 -0.00325960843574935 -0.181011963606318 -0.466108927378275 3 -0.425562359911838 0.196484373487409 -0.171508491892219 3 -0.08122 -0.17157 -0.23812 3 -0.00132899754829219 0.482319930956015 -0.131419493195154 3 -0.02703 0.32919 -0.02703 3 -0.23621 0.14603 0.0163 3 --0.18566 0.00588999999999995 -0.19062 3 -0.282035126815656 -0.110685525740661 -0.107684136146945 3 --0.225909352602753 0.351999343646422 -0.274217628285614 3 --0.18386396937318 -0.178095599762173 -0.427604255502352 3 --0.163524600099628 0.284772900501927 -0.0689500693522844 3 -0.0303251388949478 0.0135544679288806 0.0111963336816713 3 --0.00885807525154286 -0.26929263458482 -0.421232935621598 3 -0.315839845235183 0.385253878654473 0.0210172348858291 3 -0.413894136571697 0.28062705520863 0.00136991063790604 3 -0.176576102323868 0.46795086863332 0.00769654242603646 3 -0.432309573905189 -0.191883845514413 -0.16113533006974 3 -0.485390294904059 0.120195675861187 -0.00514242329856601 3 --0.00192940201180808 0.49684402325595 0.0554966874578388 3 --0.39009372908812 -0.00518722907095392 -0.313032039133652 3 -0.49914289368151 0.0291461233318954 -0.00543147978220898 3 --0.0540036409420107 0.274408896920336 0.130873446091573 3 -0.241628606539906 -0.382078538896118 -0.212925256165631 3 --0.175082037853692 0.468536371970502 -0.00419933340374384 3 --0.29903 0.17874 -0.02787 3 -0.00413179905130145 -0.396435456646393 -0.303600675564715 3 -0.480682249886952 -0.137633244776058 0.0100220215995482 3 --0.12204399058123 -0.210324343936962 0.00213018244420859 3 --0.438936112192437 0.15343789281334 -0.18169801802475 3 -0.437139589623883 0.165092994606868 0.175797212204292 3 -0.0278453794903549 -0.329808651200813 -0.0401914245461373 3 --0.308702652073837 0.391679024309034 0.0137832956820682 3 -0.235472272553025 -0.0267752458512215 0.212193953352263 3 --0.006394978723269 0.47427502201539 0.158668251757676 3 -0.396804493801327 -0.303807855847863 0.00966662690504705 3 -0.227636384150534 0.379202777840144 0.232743635531125 3 --0.25489998371951 -0.373671771347771 -0.21271769341762 3 --0.309879482596301 -0.10197300164659 -0.00231116708133322 3 --0.419832842411271 0.270803029075102 -0.018329003273368 3 -0.00446534467784998 -0.479392942654174 -0.14188612786296 3 -0.293387950130592 -0.404668960195737 -0.0117431167925522 3 -0.06909549840384 -0.25752842462979 0.156959792022163 3 --0.434988741514951 -0.161752269190433 -0.183240867252733 3 -0.425946483095473 -0.184158872435056 0.182224869891581 3 --0.181206855281379 0.0306431763050976 0.215471689781503 3 --0.470593273156677 0.169075892145267 -0.00174408475125604 3 --0.030231333034252 0.143591369103354 0.299253877806597 3 -0.000327874571006803 0.390317850550249 0.31059578630547 3 -0.170320572074684 -0.469831157239533 -0.0176799216093443 3 --0.25207476855656 0.369846031035645 0.223051142543009 3 --0.49973191361325 -0.0201678474382601 -0.00137308631879185 3 -0.389430391641598 0.00426705067130484 0.313972871928743 3 -0.00864571120677338 -0.499051999768883 0.028905575041805 3 -0.0248673354192636 -0.166160408747881 0.302254264500519 3 --0.461844857279303 -0.191410097214307 -0.00886898118333596 3 --0.427555444691048 0.186496421864363 0.176659565323205 3 --0.167000116706109 -0.471203780536846 -0.0118171739208143 3 --0.403122913557621 -0.295394752421379 -0.00954353360347587 3 --0.334171505783939 -0.369152523609239 0.00703242285091332 3 -0.0114431558931726 0.316748895958396 0.386383840721525 3 -0.168717000911503 0.158888059084251 0.442812859702898 3 -0.243232942765714 -0.37983268764039 0.21538294524482 3 -0.00422659155661675 -0.47936412722791 0.142041937100142 3 --0.43610767355182 -0.164242376974814 0.178420303006774 3 -0.00472481168678918 0.130938755216529 0.48256873523176 3 --0.153626938231159 0.210464173664778 0.426821446035094 3 -0.187636643578622 -0.180053626765099 0.424768181225969 3 -0.00815697562448081 -0.388141642693709 0.313075593826731 3 --0.266892355944875 -0.368914783446777 0.206466067035712 3 --0.333383807537645 -0.00641901394179267 0.372610132777941 3 --0.00677528800575866 0.0322958733250622 0.498972624170433 3 --0.00844385115356938 -0.316825502104455 0.386517632922366 3 -0.00765367170485598 -0.142630661820277 0.479285748948051 3 --0.176877324757134 -0.169342177679833 0.434955130810149 3 -0.463957537522003 -0.17517664720761 -0.0744358439803836 3 -0.422045101651099 -0.25617451877435 -0.0841072240545585 3 -0.460305828364947 -0.170596098684225 0.102024419776746 3 -0.419193042661543 -0.25077924927737 0.108752683393358 3 -0.0998203601369578 -0.190504612529174 0.453026621872574 3 -0.0940932934171252 -0.251982121856193 0.422214009682931 3 --0.100231755229831 -0.18707187732792 0.454317901638469 3 --0.103115808988831 -0.252544549263459 0.419516267595722 3 --0.0996610372764921 -0.182571172152099 -0.456409054277118 3 --0.0935752863071488 -0.253261259993571 -0.421574056191228 3 -0.0877776069123041 -0.170906941786094 -0.463193962166722 3 -0.0837283489125256 -0.250991489930602 -0.425159379181896 3 --0.462531907997036 -0.169392775345213 0.0946714305078336 3 --0.43186630687076 -0.247045414258765 0.0603806777157516 3 --0.465479277230223 -0.160600790658484 -0.0945404018070125 3 --0.429989121025992 -0.237096022325893 -0.0989621634366752 3 -0.0948365261798125 0.166551487593964 -0.463406172719299 3 -0.0913966394858442 0.245958293681935 -0.426517917054215 3 --0.111554327610513 0.188889980579411 -0.450898110660489 3 --0.0869827075632027 0.249701916741614 -0.425395555727076 3 -0.466608117374197 0.162744056234446 0.0848729734248103 3 -0.42628958573703 0.246063711994842 0.0920297755370193 3 -0.462303466143314 0.170707999384796 -0.0932345093020952 3 -0.417171550605481 0.258062577344655 -0.0994445243178224 3 --0.472310906420738 0.139978323133974 -0.0937868776965526 3 --0.438918612337113 0.220428319683638 -0.0997472388961579 3 --0.463787089836714 0.160269127067702 0.103648376289114 3 --0.430548748530729 0.243653521455151 0.0788909112758799 3 --0.0840449477383605 0.17374358250546 0.462815775785136 3 --0.100414875600507 0.235538096800077 0.430566803122263 3 -0.0817013482018211 0.160910454899832 0.468008852997391 3 -0.0894062907559704 0.231153565536317 0.435793625201636 3 -0.088538451071696 -0.484951640563154 -0.081711445965402 3 -0.0852126939852565 -0.475382797453395 0.128328244277548 3 --0.0974023190414141 -0.48681060160457 -0.0572693654158318 3 --0.0942438209807494 -0.475862979558836 0.119777138060168 3 -0.0851278890875008 0.48710881716898 -0.0719814843272709 3 --0.09536056102413 0.482967352743704 -0.0856359695285265 3 -0.0888190343607528 0.490464235400488 0.0355189953391816 3 --0.08787799624447 0.482258916841871 0.0970613589512334 3 -0.0943863502116786 0.0847063246831011 -0.484812145079533 3 --0.493637299831998 0.0656233816821056 -0.0550014802301512 3 -0.488153352551318 -0.0953292975917084 -0.0650929315105729 3 --0.10491644970483 -0.110714527601068 -0.477773326707894 3 -0.49001945008147 0.0776958194490114 0.0708094466425823 3 --0.0902775989567925 0.102768630836331 0.482386431391938 3 -0.0988583829743329 -0.0731027399487893 0.485686245595984 3 --0.489432478041238 -0.0988342129225193 0.0496006232457894 3 -0.490341459054018 0.074698815182891 -0.0728287034126044 3 -0.091848269878151 0.0812960225858573 0.486116100788544 3 --0.105927914473142 0.0969504519607117 -0.480271064522733 3 --0.484496667589632 0.0977607330654446 0.0852198046984342 3 -0.0975987674574088 -0.0889446581297601 -0.483418682140503 3 --0.104439778743176 -0.10447311427216 0.478982894897553 3 -0.48714283330773 -0.0952015073184988 0.0709817504294062 3 --0.489636289182593 -0.0981970731545358 -0.0467727267476651 3 -0.103637728799358 0.31040036733217 -0.375357336048716 3 --0.379454763794855 0.298001016025517 -0.123665069047315 3 -0.363433539392296 -0.325113008048645 -0.100675804205029 3 --0.113296322003384 -0.325030266274044 -0.359853062147008 3 -0.361277873969716 0.333306025787719 0.0795898078767442 3 --0.0973833435442197 0.306853791157429 0.380072938269164 3 -0.0968811947530275 -0.320384883370174 0.3686357463385 3 --0.376534263379062 -0.313594974324934 0.0894282790952184 3 -0.132026846386778 -0.435314783612187 -0.205305015400631 3 -0.220610558408406 -0.43488197682669 -0.107433977193524 3 -0.23619466973308 0.421750448428229 -0.125147585634066 3 -0.140358183374916 0.438546553363651 -0.192266419427452 3 --0.0988597202543861 0.307623202490686 -0.379009178613756 3 -0.371011173859207 0.322611968000217 -0.0797092171380049 3 -0.355381520799954 -0.328059000751344 0.118281706696483 3 --0.0980456922606407 -0.305065013404104 0.381367586263784 3 --0.375152120014877 0.322408045150108 0.0595287974745001 3 -0.102935475130396 0.298662009985764 0.385207321915342 3 -0.101195898863836 -0.311122343831223 -0.375427847839625 3 --0.371360443473076 -0.312998994021935 -0.109789689205639 3 -0.153239467494115 -0.440531015714894 0.177133166814191 3 -0.212558460864478 -0.432891107124502 0.128843897826697 3 --0.215490001387338 -0.427025878572128 -0.142617584849939 3 --0.144966725636782 -0.430132111418838 -0.207596790047907 3 --0.229465178702871 0.415389473333404 -0.155371407083044 3 --0.140618459252347 0.438486142882288 -0.192201796715802 3 -0.157964911839067 0.429529931314534 0.198951376915972 3 -0.211814258834005 0.436163454256886 0.118699348939796 3 -0.294763103377706 -0.387410454885566 -0.110540325335786 3 -0.246901755207714 -0.436211932582389 0.0053531305532647 3 -0.286740868376012 -0.394519858502126 0.107390165239077 3 -0.138774799686629 -0.400273347265786 0.264834651190811 3 --0.00301336634687688 -0.445400470162097 0.229939545424468 3 --0.137130174585366 -0.40265860508846 0.26228419274979 3 --0.147874743614584 -0.439464784209511 0.184363061123968 3 --0.133461903615098 -0.388069418838137 -0.284433559956595 3 -0.00713820319351577 -0.446348824901019 -0.227995690926746 3 -0.145456593153004 -0.396811114689974 -0.266207647308135 3 --0.297296552590654 -0.386942792114963 0.105089270773334 3 --0.258003457970581 -0.429332671738262 -0.0120379095174575 3 --0.226054288088537 -0.425531823850868 0.130674368306049 3 --0.299162215649029 -0.385784083647557 -0.103887165469171 3 -0.134332008461294 0.391797953032205 -0.278931909190811 3 -0.00231097843857708 0.454302672904779 -0.211540287101205 3 --0.131759430596137 0.40820461271994 -0.256431902775738 3 -0.28310775260582 0.391998026756917 0.125161644932275 3 -0.256463410541042 0.430448391189172 0.00014204006670604 3 -0.308240520218905 0.380424840677734 -0.0955954903413336 3 --0.310325024571733 0.376855370499413 -0.102416746331325 3 --0.2392988365697 0.439183480957239 0.0303392865265745 3 --0.301623516550104 0.380966001880835 0.11367427306962 3 --0.233045212880647 0.420541643966558 0.134702272425908 3 --0.145318293871871 0.396599706304536 0.266763836788857 3 -0.0021716750915447 0.442832631751116 0.234886469925269 3 --0.135997652195036 0.433490608653713 0.206606466766941 3 -0.152980793828209 0.37673981724004 0.289607260288404 3 -0.182178506818695 0.00692792756792149 -0.464382754330215 3 -0.460234733758847 -0.00589732594872816 0.190958460246722 3 -0.451617311287256 -0.0219104209579195 -0.206767309258393 3 -0.193896303663583 -0.00709292903125947 0.458516178632067 3 --0.458214220351848 -0.0051862061854937 -0.195370147490196 3 --0.178254913753376 0.0157431252318954 0.465782266954322 3 --0.194941244599798 -0.00268036837149893 -0.45797901015378 3 --0.452069913247908 -0.012752323387308 0.206477943452207 3 -0.207571175862967 -0.26104133271586 0.369902696351851 3 --0.345484053302153 -0.298841244550962 0.19998604242641 3 --0.347459170318477 0.267949994148498 -0.234556917516856 3 --0.228029618990789 0.314512068929196 0.312932133257322 3 --0.328134142066638 -0.319898971796681 -0.197779607879478 3 -0.208932163919998 0.31871165988206 0.322018080806538 3 -0.22139223449483 0.253995470962484 -0.365983466517251 3 -0.385558983667329 0.261364759136317 0.179328404532989 3 -0.320571247993434 -0.327719867153095 -0.197309188325577 3 --0.219163863230928 -0.285573316998226 -0.34433885812465 3 -0.216476663955021 -0.32311059314484 -0.312691754617068 3 -0.333509289147194 -0.203715865685326 -0.299349069396888 3 -0.353656714664517 0.306097641186539 -0.174192208309592 3 -0.349494233092674 0.189009803019581 -0.29071755801672 3 --0.206289529620406 0.273978326402302 -0.361624084696735 3 --0.371344439585543 0.293830127573115 0.158292232030686 3 -0.37003096342357 -0.267589170647135 0.199838160691031 3 --0.222184183583988 -0.280164813099013 0.346875323283087 3 --0.347755949176477 -0.198704831852936 0.286390914635467 3 -0.319478748508411 -0.167434382402058 0.334818956056292 3 -0.296668082767843 0.091101408316616 -0.389187340609301 3 -0.288570373271006 -0.0811537779402727 -0.397974194581046 3 -0.409857372631846 0.136360156933722 -0.244647294211703 3 -0.427642683588926 0.0827998607966517 0.24342834707476 3 -0.423004651317807 -0.0908876680888848 0.248140682402067 3 -0.286321609896642 -0.0921543047824032 0.395193808871071 3 -0.292505025749109 0.116435756575918 0.383042162594011 3 -0.322317625293256 0.186365266885241 0.321463711439653 3 --0.42493433120661 0.0733919378325485 -0.251118076591728 3 --0.423904491513368 -0.0829095892757292 -0.249586848034078 3 --0.328009110445149 0.190001439173453 -0.313759601983295 3 --0.277803243872192 0.0867991215458712 -0.402602241589798 3 --0.300576517315491 -0.115138330603044 -0.377003413711951 3 --0.321602161077588 -0.186548749667216 -0.322066834841514 3 --0.283338504329576 0.0756753046566133 0.40308660335409 3 --0.283756267118695 -0.092130416337721 0.398713245606363 3 --0.325277255544981 0.195093267043345 0.313216628702406 3 --0.396911230401392 0.122804012603067 0.270990055827425 3 --0.418162670004904 -0.104428582069732 0.247753575170424 3 -0.411677547753972 -0.122333463697467 -0.249486483173413 3 --0.189291850614437 -0.0939768393163146 -0.451539237198075 3 --0.130447301374397 -0.251239172955843 -0.411333257881365 3 -0.141379653490462 -0.22382902190249 0.423895021497464 3 --0.413544666215727 -0.240339546872993 0.142248770581061 3 --0.137457192877172 0.250905788643049 -0.409011390516054 3 -0.279007925575758 0.285407560842111 0.296748293476154 3 -0.135000048045384 0.233643024072598 0.420620609466566 3 -0.466979957359858 -0.08813758890043 0.156820625245832 3 --0.467898325036463 -0.084554763506675 -0.15609163387905 3 -0.463641310892822 0.0851102662971333 -0.166823206428884 3 -0.196626506262119 0.0838222063484461 0.449583548360945 3 --0.181577125147044 -0.0876223387297191 0.456707843864796 3 --0.461504752071476 0.0896984129574951 0.169720054728212 3 -0.359037713362289 0.0977272638824578 -0.328548532402342 3 --0.102902067854468 0.0157625013745024 -0.489534352133465 3 -0.374246889681677 -0.230828002614148 -0.22806231435753 3 -0.178897096349129 -0.0866145778085739 -0.457854376466598 3 -0.284488295286263 0.273770211997805 -0.301721305365325 3 -0.244291441541308 -0.17929032628026 0.390329946532865 3 -0.429525895441263 -0.0135064583363251 0.254634805343168 3 -0.379956078881788 -0.179847682625851 0.259004373111805 3 -0.360893591907236 0.092102803613349 0.32896942049576 3 --0.428177037257128 -0.00523406909614649 -0.25726895406621 3 --0.357996373444931 0.0857598254269322 -0.33424736639344 3 --0.321346700640795 -0.00848077149999371 -0.380063766677019 3 --0.384843992919815 -0.166580938700869 -0.261091110980134 3 --0.276415151456886 -0.00741905229107542 0.41602195373738 3 --0.344236460526455 0.0926028350281468 0.345996677307229 3 --0.400854900537336 0.00165499776305122 0.294374997667162 3 --0.282758989613652 -0.189970865686674 0.355965208023821 3 --0.262138511071203 0.15800241149218 0.38813848642156 3 -0.268979589487841 -0.178801040656288 -0.373182745085025 3 -0.463050761604737 -0.103010021040379 -0.159576382379177 3 -0.28278230849932 0.186320762592625 -0.358082661473092 3 --0.206050688367827 0.102157987886602 -0.440902439669963 3 --0.250465260508807 0.182958386823238 -0.384333838848444 3 -0.257488015002854 0.218314669186355 0.360568902292453 3 --0.386337069003039 0.174040251630505 -0.254109441078305 3 -0.18220353166871 0.105465471840841 -0.452416671264443 3 -0.0982132276105134 -0.000314502023379903 -0.490654807710934 3 -0.469320483499906 0.0852399860623524 0.151984289617662 3 -0.490459534152546 -0.00459303614750528 0.0987531331613316 3 -0.487498549696157 -0.0101721562665815 -0.111764122060227 3 -0.200848229384852 -0.109042765956948 0.441848895047628 3 -0.0976107008800317 -0.00426165052932387 0.490845760000353 3 --0.469596443812064 0.0747918291512797 -0.155791365337166 3 --0.489778111828164 -0.00954509090443295 -0.101440149696377 3 --0.194351883457692 0.123005412687822 0.44174387160292 3 --0.104089160857633 -0.0205690616697271 0.488983831523052 3 --0.469067688610887 -0.0882816470284293 0.151555732258251 3 --0.488006929072439 0.000122126362084196 0.110232025999863 3 --0.285362799641163 -0.288773446708859 -0.287663331182799 3 -0.291784734233241 -0.30165548428373 -0.267918281169439 3 -0.388269241162638 0.170368451616761 0.253869341846499 3 -0.380886747746052 0.218286645376284 -0.228866282727837 3 -0.283480834677035 0.00572063351403751 -0.411299332549255 3 --0.292713870336129 -0.285888456234864 0.282988399794802 3 --0.278573162445664 0.270348033978413 -0.310070084131244 3 -0.301419075492453 -0.306823458573543 0.251471255055362 3 -0.361955492144111 -0.0902953770165509 0.328413147828907 3 -0.322531952635122 0.0044857981026496 0.379110831495097 3 --0.249217395808399 -0.206978334900484 -0.372832398338367 3 --0.359049349500976 -0.0966028246549072 -0.329531147655952 3 --0.381952512766783 0.209873675984547 0.234027593236811 3 --0.388130920147168 -0.208377605931543 0.225704455313446 3 --0.348477873222982 -0.102029926423343 0.338495753268956 3 --0.292506586834718 0.294650742576492 0.274609308022234 3 -0.352928143250988 -0.105387769156199 -0.332682239207553 3 -0.399248392517519 -0.0126560793392238 -0.296349440881548 3 --0.0696266756954118 -0.455141048384976 0.194935982809694 3 --0.285199829648831 -0.18871177605603 0.13423557054573 0 -0.0462909681695324 -0.494555675157696 0.0554286177669132 3 -0.0345124828613178 -0.498660679132464 -0.00281575889889984 3 -0.0534523727123667 -0.479501038790495 0.130598394437469 3 --0.0391224505990597 -0.496797600699873 -0.0385649266421321 3 --0.0531552270253121 -0.48543726072205 -0.106358561251288 3 --0.0429563893186705 -0.496682190336547 0.0356603159344794 3 -0.0345849447249691 0.497864299894332 -0.0279135018727244 3 -0.044743996052092 0.485602080489727 -0.10948290097054 3 --0.0460655034669439 0.496779118386448 0.0298838244919964 3 --0.0328253395898103 0.496163168262419 -0.0506634427861601 3 -0.0530671110711282 0.117438985242396 0.484417813937402 3 -0.0585607608224893 0.0331855047456504 0.496065329988647 3 --0.0458875227787715 0.484044483062787 0.115809590664595 3 -0.15460241186342 -0.459816985204909 -0.117674407363819 3 -0.0642526365653728 0.467570733874446 -0.163632629900108 3 -0.152617602999245 0.465098761570853 0.0984692352893433 3 -0.0679617629250375 -0.453961576579506 0.198226698827158 3 --0.355559265124178 -0.246165101908665 -0.0482380764939738 0 -0.192795262409876 0.146966007964205 0.305956035365206 0 --0.0645014377596259 0.447095526975741 -0.214720253002755 3 --0.0945349248575915 -0.489894545979687 0.0276697840716776 3 -0.0593702651283592 -0.0505307620217191 -0.0176287084415669 0 --0.0680331565244841 0.46574089160768 0.167162222482423 3 -0.068983043790638 0.456157203508125 0.192580572047359 3 -0.157732589502428 0.218192828736092 -0.143585299317557 0 -0.0436959966411078 -0.363795553996754 0.337277402154132 3 -0.0645346507139627 -0.412255095386062 0.275780112816201 3 --0.0505472382299074 0.358935900999695 0.341356999564974 3 -0.148962951859733 -0.193239045209316 -0.0483600272913677 0 -0.0623680036008849 0.495832769487121 -0.00266746161859355 3 --0.0472085844978157 -0.0542543605560932 0.495468946925712 3 --0.137121671135497 0.468255318830733 -0.106100989126665 3 --0.157209297217236 -0.460284375685749 0.112403364919077 3 --0.0110680696168979 -0.0123896832067434 -0.320122046419604 0 -0.149241502385124 0.3023437704416 0.36720643364619 3 -0.158317227107502 0.296079081443963 -0.368610056138697 3 --0.137393611054613 -0.463875856391338 -0.123211459444315 3 -0.0541033166635914 -0.051668016618727 0.177511456652542 0 -0.0699187542818479 -0.460950590864524 -0.179249831578508 3 --0.0823966864803181 -0.401287523707082 0.28595399158374 3 --0.0478623651160561 -0.372647895671036 0.327182217734472 3 -0.15530432333437 -0.466418753944971 0.0876655660894015 3 -0.0736781124616019 -0.413546815162776 -0.271700518727566 3 -0.0485924535172314 -0.366926936336019 -0.333149104255633 3 --0.148143156823167 0.31184539641726 -0.359622878841395 3 --0.145415617872416 -0.294179585652664 0.37534591727153 3 --0.375992920561628 0.0988275897250934 0.203083276815683 0 -0.0600009823252872 -0.219834847883933 0.446382145181537 3 --0.156205615464425 -0.130204404957276 0.207854721696477 0 -0.02708717492963 -0.0777857508886661 -0.234391436188129 0 --0.040097684701465 -0.280544410948229 -0.412254025609813 3 --0.061146667409064 -0.217827697743445 -0.447244412764295 3 -0.0637150838950887 0.404448611576838 0.286681819217344 3 -0.0551681487803344 0.351364066617432 0.348412816105007 3 -0.0545076451584526 -0.20733942514306 -0.452817461317215 3 -0.0509793086538702 -0.282315165239414 -0.409637011894308 3 --0.178417980275326 0.121278895019153 -0.204993927696334 0 -0.0393216489799572 0.194192080309884 -0.459863876798807 3 --0.290559640924953 -0.173780846303178 0.0514062417894334 0 -0.0527541930461726 0.259296808709834 -0.42497455324974 3 --0.00767538895578401 0.193522533317323 0.0832356851384881 0 -0.128659557553178 0.137522065871296 0.0375694000806353 0 --0.0444243146394841 0.161128284260187 -0.472139662274233 3 --0.0606692126456967 0.213467933137053 0.449263173239964 3 --0.0500739742403733 0.287411018861512 0.406042889793703 3 -0.249372464611342 0.255146306380202 0.22963570824272 0 -0.187499661649199 -0.251129031115913 0.134351538793028 0 -0.0562623416658216 0.207159160185026 0.452874401823557 3 -0.0607359243441504 0.285467074471343 0.405892250365009 3 -0.0508963395545929 -0.486366656817196 -0.103175663440536 3 --0.0443273195874423 -0.479822495337845 0.133015531809536 3 --0.0428274727819424 0.480090834240699 -0.13244436351847 3 -0.0422045910827965 0.474767788121995 0.150934068669199 3 -0.0398241114376995 0.494619410128065 0.0597845818849013 3 -0.0545450186465122 0.0716858447085494 -0.49280952173286 3 -0.0605420414032614 0.133134354807758 -0.479329718563731 3 --0.0498069166166687 -0.070709294180502 -0.493575230699804 3 --0.0645744916992441 -0.13961123840707 -0.477171179990605 3 --0.015850278050594 -0.117944696665281 -0.134209080265633 0 -0.0637055071716145 -0.0505505424394523 0.494133153738026 3 -0.0638066032948099 -0.132351715830931 0.479340726610399 3 --0.0568095930826675 0.0522352117541705 0.494729389305502 3 --0.0592013830651998 0.130878537080683 0.480134191516978 3 --0.0615001621793329 0.128668321521151 -0.480630866467862 3 --0.0441657701477192 0.0761125939600827 -0.493271360339211 3 -0.0600137617643497 -0.123956158589686 -0.481894223835941 3 --0.0460453218784909 -0.162421597430834 0.471440166412534 3 -0.0644618446666178 0.303341834806402 -0.39056511583801 3 -0.0551559496068218 0.353612250917301 -0.346023407622704 3 --0.193804195053821 -0.0575753523341889 -0.112995648153059 0 -0.0419581195807606 -0.293748934794669 0.401752253014829 3 -0.0534547550527182 -0.241714524482002 0.369481415933513 0 -0.169555532454743 0.458271508477623 -0.102296858750199 3 --0.0499181893292577 0.347624576757719 -0.352953974749988 3 --0.0605276313889615 0.298112250098889 -0.39561746977865 3 --0.0458361970769485 -0.312465365229833 0.386150726517622 3 -0.392843577276763 -0.131882447783792 -0.0233889266752479 0 --0.0554285053112573 -0.132556021240227 -0.374351085620444 0 --0.183769343998958 -0.196035441507499 -0.0752664725081673 0 --0.333855199149116 -0.0604991038628248 0.0537509291920083 0 --0.247509799072083 0.430147330964962 -0.0634852186688334 3 --0.387852528877507 -0.125615465361443 0.177752445049657 0 --0.0508187338353593 -0.345239888048748 -0.355084208552865 3 --0.0356706157106658 0.106472401572142 -0.451867005961993 0 -0.0760751067403471 0.389792793762424 -0.30215737743394 3 -0.0714788478461775 0.437071612061468 -0.233455742897792 3 --0.0389114623782825 0.355481725364639 -0.244493074892693 0 --0.111769918158741 0.293877597614102 -0.308196525852922 0 --0.065489416060847 -0.220896981331234 0.445045889516516 3 -0.0529942027099082 0.00535023020350922 -0.497614082708694 3 --0.0386621225757984 -0.0806239884702863 -0.233643453419084 0 -0.0171578101512828 -0.16901779208423 -0.0923214545807077 0 --0.0420747536836063 -0.00639678279206879 -0.498662795795644 3 -0.15624480019279 -0.294579842449135 0.37067508428782 3 --0.165007228255569 0.315316076159937 0.349416418944523 3 --0.0646787004994422 -0.457608186048014 -0.190875296276249 3 --0.141859613187144 0.461525849540587 0.126735197928372 3 --0.159182942788095 -0.298484946953676 -0.366251859154309 3 -0.149843618346464 -0.301409539754116 -0.367759216244769 3 -0.146525725733611 0.159141280503511 0.111117896092094 0 --0.0674030583794964 -0.411885864641459 -0.275569469146934 3 -0.0396087942710819 -0.0664086797909293 -0.494774644949172 3 -0.365628323886208 0.0642762846433107 -0.261552818585636 0 --0.0248749758392491 0.43506288432334 -0.0116407864908815 0 --0.0340114292630648 0.457421145632734 -0.200715394704478 3 --0.0251950897975622 -0.41714893574651 0.274740214731111 3 --0.060874047912685 -0.353143037767686 -0.0520192573614737 0 -0.0395123850645708 0.43940265491133 0.236947848397555 3 -0.0326686065400656 -0.407523121649418 0.287540342336218 3 -0.030660693178662 0.381405021533252 0.319804675896685 3 --0.0402059343301617 -0.450449589316055 0.214872825913905 3 -0.169089192245065 -0.0706914834937503 0.203016174859785 0 -0.0411653609586073 -0.454270669203262 0.206259392740944 3 --0.0384748037037542 -0.386588776669153 -0.312851034570546 3 -0.0398477038748601 0.449044206877031 -0.218664194700504 3 -0.0217503299905193 0.313325362917446 0.252279466142916 0 --0.0357525424835743 0.427875983857371 -0.257812151890686 3 --0.33079811614382 -0.24116821468224 0.148463529783398 0 --0.0352543263870185 0.458747954933377 0.19731851654445 3 --0.0375028679922805 -0.470443468807458 -0.164631891008854 3 --0.197738662334695 0.017590203310152 0.0726599597016344 0 --0.343418897592313 0.014526838777516 0.23506449546348 0 --0.0365753922275585 -0.435521208493649 -0.244612989113693 3 -0.0407915016530307 -0.452453649958886 -0.210957554785487 3 --0.133620134364316 0.363378622687658 0.152682196818154 0 --0.0301650927356145 0.377688773018785 -0.323997908245417 3 -0.0265337149603317 -0.417224962705905 -0.274664821142123 3 --0.0238431446709205 -0.0695969313079043 -0.495220817034986 3 -0.029423823947397 0.122512956277534 -0.484421523145716 3 -0.0316583008280609 -0.0941305760265362 0.490809621875078 3 --0.0281683763376094 0.0946039197265132 0.490781411325718 3 -0.0236584864760355 0.394171670441825 -0.305733048102645 3 --0.0298261333363911 0.401934081245187 0.295246430522139 3 --0.0344210252271261 -0.425436847005026 0.0862112738793681 0 --0.135373739779238 -0.0224575 0.351179727850927 0 -0.211849239557296 0.22820873493807 0.053056071918793 0 --0.0480209011019315 0.0590275702901946 -0.428267264352891 0 --0.0132607812650518 0.163032763851371 -0.335261959204322 0 -0.325770351467379 -0.145316199670609 0.140381296922667 0 -0.105336199710417 -0.178634388049452 0.372592202692868 0 -0.177839329627636 -0.114577214695565 0.12904164445272 0 --0.13046181165344 -0.0508299391533377 -0.343515391477584 0 -0.12247 -0.176115 -0.337325 0 --0.373105 -0.157505 0.07988 0 -0.104885277874396 -0.437094219067691 0.218236080735347 3 -0.098255 0.15978 -0.368235 0 --0.09612597453103 -0.120661948776351 0.0382227223876501 0 -0.0163949999999999 0.216395 -0.352225 0 -0.332421489662272 0.157971145007158 -0.0787030163998381 0 --0.355510864087579 0.17389385525911 -0.0887372973184119 0 -0.175213127508952 0.0993875660643914 0.0832208012605031 0 --0.096655 0.160355 0.3756 0 -0.0488088444362434 0.193436955683395 0.364970551073445 0 -0.0170353753826267 -0.401014138744401 -0.0255252872582026 0 -0.0530681751569329 -0.408121610824783 0.026038175156933 0 --0.0260381751569329 -0.408121610824783 -0.0530681751569329 0 -0.167455466965127 -0.274785882714042 0.296328938966467 0 -0.0366673341286473 0.204537127915776 0.245170325914874 0 --0.024925 0.374175 0.05672 0 -0.0588674849586265 -0.0295975939735896 0.382133033390435 0 --0.0448252904006103 0.372497838231312 0.0766202904006102 0 -0.132402071563293 0.134553474002111 -0.464366898882864 3 --0.171705964752653 -0.0653833115409009 0.159995732061026 0 --0.193672275776373 -0.288135611620581 -0.186695192525948 0 --0.0764935612878992 -0.0490307442351431 -0.201655476709542 0 --0.130424961726246 0.15065279677178 0.46021277211353 3 -0.138259452174732 -0.131770629169984 0.463361682091313 3 --0.399585274060606 -0.105596964586861 0.0427074863989751 0 --0.0498608165693258 0.351220305630678 -0.0484231945576599 0 --0.0285851835033174 0.327024596939541 0.375452358892258 3 --0.0905221067722875 0.0699302179176844 -0.245711945069295 0 --0.378963863023976 0.1353205149966 0.0732431908258013 0 -0.0810587519251814 -0.141222412233655 -0.341913303925383 0 --0.10681 0.07696 0.26333 0 -0.340211335922215 -0.0698808993165262 0.185388323581597 0 --0.374086427703426 -0.118041404925502 -0.102761520996234 0 -0.0903459070211894 0.220143183243595 -0.334248019377034 0 --0.313746595113017 0.229727222908833 -0.121356208124697 0 --0.174064095354508 -0.379026762935611 0.164529607119181 0 --0.355437360206544 -0.195278886537918 -0.110856175898584 0 --0.0809708501057803 0.41467535846851 -0.0614441615871802 0 --0.204102904179829 0.197802776398143 0.407419613995104 3 --0.138935751958687 -0.0498208959265931 -0.478159482241831 3 -0.362155905613427 -0.145378795655332 -0.08458715740713 0 -0.124625858785742 -0.379044004715911 -0.0906880997302786 0 -0.318485158945119 -0.136509207029181 -0.205431957311729 0 -0.0775388444362435 0.0340419556833946 0.357150551073445 0 -0.069720502393579 -0.274224421987452 -0.362510729690118 0 -0.0245661611573886 0.229457548704986 -0.0816815023299884 0 --0.357787136323926 0.235592571442132 0.137295725054046 0 -0.122482205310427 -0.204794700164814 -0.440917965723996 3 --0.388940381571515 -0.246127221958529 -0.190671045987662 3 -0.147525 -0.32291 0.192335 0 --0.00909073406760025 -0.184262836991447 0.384306864133039 0 --0.163505472430445 0.351316716475726 -0.134765408834436 0 -0.0614840558231362 0.33587513326929 0.038961009446048 0 -0.113300992415774 -0.362019828136151 0.0855641944264364 0 -0.13162 0.23761 -0.00536500000000001 0 -0.146271591619194 0.372873443480144 -0.21736860196022 0 -0.160877953510595 0.299081591621797 -0.282829009688517 0 --0.160194578977667 -0.326925084647363 0.0623079659667403 0 --0.0363813910924395 0.0669536178712172 -0.293140982631387 0 -0.073301192124285 0.385382653648221 -0.113242504680696 0 --0.0932568067047514 0.332593029489573 -0.0349923499406192 0 -0.317953814050217 0.0227359209252277 0.22872448423636 0 -0.416113795723479 -0.034781157234742 0.068507647463853 0 --0.155320800174013 0.364517917052029 -0.0155008555140027 0 --0.178171248552791 0.353278724631608 0.0422811473349338 0 -0.00215306811260829 -0.280876482683879 0.0959640922211761 0 -0.073301192124285 0.385382653648221 0.0862125046806961 0 --0.0933500332002766 -0.101022979625044 0.427734149919788 0 --0.0429078679260453 -0.151659961147503 -0.175782500746687 0 --0.24153 0.0963050000000001 0.09206 0 --0.12225829094647 -0.29005370331952 -0.129837233702102 0 --0.0350834011565029 -0.176912419240273 -0.339418176517381 0 -0.125596192124285 0.339592653648221 -0.102410004680696 0 -0.101113190825801 -0.0434194850034004 0.378963863023976 0 --0.0535101499932998 -0.203176637969573 0.14872303388937 0 --0.195342143837586 -0.13885746987614 0.279968479114591 0 --0.0917085447982896 -0.128536431112306 -0.13931485610761 0 --0.307413898580309 0.199827406024457 -0.223884688329396 0 --0.0501765374801907 0.139568945162113 -0.398442708982128 0 -0.364685162071064 -0.204898619324383 0.102366653459455 0 -0.30652774123701 -0.194297644255372 -0.143703467048514 0 -0.0245594533824588 -0.347780184398903 0.356164159617619 3 -0.365231131481964 -0.230339261859738 -0.0434485571812104 0 --0.0160293442010517 -0.387528802824258 -0.313757474736455 3 -0.360302812759243 0.102372534056142 0.226050000159979 0 -0.15132 -0.109715 -0.020745 0 --0.027088766689578 -0.077620732116245 0.265997949291703 0 -0.283369178325262 -0.239496460296533 -0.0603976466308022 0 --0.00989330214210465 0.423089745205555 0.0406280825757338 0 -0.321887658280648 -0.0163641366902701 -0.154897661065475 0 -0.0200317805359863 -0.236311994175742 -0.440658066835578 3 --0.00731124865671612 0.0113755034707114 0.291782450435228 0 -0.204767354731425 0.169762602917692 -0.265929418963683 0 --0.30037822350962 0.0113645335762159 -0.183276718213756 0 --0.221371819710442 -0.370672955239849 0.0720118315242391 0 -0.0269772398449619 0.0198739054534439 0.441276865818721 0 --0.192081789027813 0.273314637104824 -0.180744621331743 0 --0.0575084866540017 0.0232055505879024 0.399860548922967 0 --0.176838420714151 0.440805263959496 -0.152803762726961 3 --0.227110892047188 -0.223154120390215 0.293212491292882 0 --0.103235855187974 0.403653952415951 0.276029606886434 3 -0.331799548337436 0.0972938727875519 0.144740641083965 0 -0.042531292156049 0.159209522410176 0.16030058990562 0 -0.0135149999999999 0.387875799686783 0.100384618163192 0 --0.12299499644872 -0.462674624718819 0.141613113718508 3 -0.0509244222181218 0.0203759778416973 0.185595275536723 0 --0.0825111921242849 -0.320580153648221 0.175112504680696 0 -0.031033191648793 -0.268024187517285 0.145999662706345 0 --0.0377922035999757 -0.319136858098024 0.195561282425335 0 --0.42870976360245 0.105759781814948 -0.00481465880457188 0 --0.0166000578601241 -0.499640627385814 -0.004636346988107 3 -0.140672422361459 0.0775371961040361 0.163951112756491 0 -0.0627559678579421 -0.131065367053033 0.16262675226802 0 --0.185028124049883 0.405418496407849 -0.225127907779229 3 --0.00995430885737036 0.359473158151318 -0.345364480296213 3 --0.102816674715062 0.23231052502725 -0.361627741960438 0 -0.292002136323926 0.218757571442132 -0.0951832250540462 0 --0.0844623566948219 0.325566593772964 0.192126453638052 0 -0.0678753335216443 -0.0950258373605864 -0.420705860203783 0 --0.00695271348857002 -0.0609418517476876 0.496182493032593 3 -0.0281905567730405 0.185365118743271 -0.233683813981961 0 -0.0847647256296186 0.000300711415477717 -0.297447254971652 0 --0.0665075315895416 0.204060937746699 -0.193167400888089 0 --0.0884272520954266 0.0197970672937915 0.0502870732028723 0 -0.1754798522108 0.0485935922835482 -0.346582283689187 0 --0.198973653986571 -0.29424285382764 -0.052489776921924 0 -0.279997205870017 -0.327265042829677 0.0468435192731242 0 --0.279380485252666 -0.254704271810546 0.0978882822138709 0 --0.210183458183336 -0.187629992139014 -0.00361539174236586 0 -0.126824344568398 0.260571956153147 -0.40691550477353 3 -0.138722245715053 0.0316322657426042 -0.262986109315331 0 -0.137173486654002 0.0731119494120975 -0.413533048922967 0 --0.129652439977842 -0.344491409661425 -0.0488693798044104 0 --0.00240526987166612 -0.237249324114294 0.440117617627421 3 --0.133305540011415 0.284089885856646 0.387873946567378 3 --0.0724837077084147 0.396236593362692 -0.129138271232444 0 -0.0708701326042136 -0.286049803252579 0.403224795151142 3 -0.117348208873405 -0.134681808469484 -0.408829219562019 0 -0.0279414535242981 0.219226798622013 -0.157802862938593 0 -0.0682250102725005 -0.494848746211172 -0.0145387521483752 3 --0.105690879380939 0.387826191308415 -0.17708680610557 0 -0.263523464661552 -0.0549618516340601 -0.196927978902348 0 --0.0885246877486855 -0.476638796744039 -0.121067482144263 3 -0.0982537752441671 0.206063780236438 0.284647673901217 0 --0.1683381464933 -0.076692046270406 -0.316898549167976 0 -0.221493541876948 -0.175226368661546 0.271426289777474 0 --0.0524515558231361 0.298140133269291 0.0312627405539521 0 -0.447195633494098 -0.223121536032723 0.0134328468189111 3 --0.338053699262644 0.0582800915554119 -0.268673863971341 0 --0.221151545606703 0.212751234401611 0.0615254925876491 0 --0.0587133557534675 0.432987310279231 0.111415974975174 0 -0.0386173329223867 0.424885692704943 -0.0304219578353728 0 -0.013935 -0.166625 0.38728 0 --0.0586386768939824 -0.222801196053474 -0.279397545181065 0 -0.127383648642517 -0.133087419048278 -0.466231632255055 3 -0.116958270933396 -0.228317833813785 0.306521396893584 0 --0.0283777268400379 -0.0143167049551841 -0.37977023905515 0 --0.027947143110645 0.00420862976691749 0.499298789546497 3 -0.094131258818591 0.337358114963483 0.123428199187384 0 -0.0821358550821143 -0.16316740897383 0.0885389237106797 0 --0.321893411322858 -0.279510008033948 0.00755968154555997 0 --0.268538679516487 0.0506638543660944 -0.264260499163997 0 --0.212186013823909 -0.340074010528897 0.139924636921541 0 -0.19257 0.0664 0.31658 0 --0.141214275274305 -0.245681552733675 0.183935292262682 0 -0.0197021466323226 -0.294655321584929 0.297045792467723 0 -0.405003791716507 -0.112259649491528 0.132684471364565 0 --0.021466581344847 -0.00906902231094803 0.374498356288457 0 -0.28457773526642 0.00388151447695573 0.134852098800835 0 -0.497249961250788 -0.0526107210717055 -0.00348060563950853 3 --0.137477599177586 0.272749465087339 0.178381626982344 0 --0.231063059967607 0.00630808604037902 -0.280989522143151 0 -0.0348191858317501 -0.154205556176512 -0.362230693615371 0 -0.14253 -0.15783 0.174945 0 --0.081810537229719 -0.113035195185344 -0.428546576803358 0 -0.024887018799658 0.0458529970615231 -0.108191535067612 0 --0.190077458732271 0.157536923568998 0.282450555088702 0 --0.193404976977684 -0.401989456829734 0.0386153667646558 0 --0.403428875245626 -0.200044489382503 0.0217014862322684 0 -0.0978662222323166 0.348439490236166 -0.0463947043092768 0 --0.266831262653082 -0.145601285592372 -0.19072627901068 0 -0.145559602941378 -0.0446573886450021 0.476577845577465 3 --0.175832726003933 -0.334477793554948 -0.00180983859188771 0 --0.321955850318001 -0.11798672443095 -0.253874161542618 0 -0.181828461124084 -0.211990095287394 -0.262130904534185 0 -0.233404341346477 -0.0880539652665058 -0.331219800013665 0 --0.0217606129978763 -0.225254037948626 -0.28919000320386 0 --0.0506488547003128 -0.248911209960326 -0.351687523495561 0 --0.166021472527837 0.204184590655925 -0.235624556116386 0 -0.227133919734881 -0.104313292744258 0.0345275856569874 0 --0.406481567040512 0.0122123098911024 -0.133696811294726 0 --0.0927495414040736 -0.267637880335852 -0.208060929503398 0 --0.0107119405119834 -0.285623525958706 -0.233580046008767 0 -0.130420328480448 -0.118504323289577 0.245918123546717 0 -0.0952747238152389 0.359736243160324 -0.249850318191713 0 --0.0905720294870799 0.0394963823023445 0.490738882786435 3 -0.1441825 -0.14698 0.34218 0 -0.0977021480108651 -0.401187755627743 -0.024160392784746 0 -0.30485432742414 -0.168385284855722 0.0403988961494599 0 --0.370843740217477 -0.00993514654480127 -0.00502594562055048 0 --0.0698926204679018 -0.295843668013045 -0.395814960402741 3 --0.271036960721674 0.15097502460025 0.207475709266356 0 -0.108974913586182 -0.401849913121019 -0.276293346652642 3 -0.0478917519376679 0.283821098310147 -0.117472216671498 0 --0.0715850892784158 -0.235454844238466 -0.357058993493705 0 -0.382568008835017 0.0231331576507914 0.188029277106516 0 -0.109972428085123 -0.297919036752776 0.315903097742814 0 -0.135465844242559 0.100352876914133 0.399946207783601 0 -0.189921531526786 -0.381236683801994 -0.261080882477149 3 -0.154649721393539 -0.0212228129510051 -0.379414128292012 0 -0.0642511127416365 -0.18184567203783 0.347811710720228 0 --0.449704342871147 -0.0699289632672183 -0.0109833596941881 0 --0.0682 0.108505 0.289 0 -0.0809220399824633 0.119370146747786 0.326715417389139 0 --0.0018159337400635 0.346288169028488 -0.20041589052225 0 --0.284053316161508 -0.0877761223616967 0.229015608009134 0 --0.163324074006686 -0.0837910061639029 0.331462174461525 0 -0.424879999352974 0.0833466362481957 -0.0169631967282287 0 --0.0133308158951077 0.432459844652415 -0.252800211042227 3 -0.0982089724022425 0.462241728542605 -0.160920210358838 3 --0.245979980203927 -0.347872118300389 0.0109937859931962 0 --0.00496110179998788 -0.248938429049012 0.247295641212667 0 -0.209168953638052 -0.362846593772964 0.155704856694822 0 -0.0290283716635004 -0.0756811123530244 -0.403146387230742 0 --0.344612241211275 -0.127150751941817 -0.162991475198996 0 -0.0329762164958188 0.347682925116186 0.15939119316654 0 -0.118050952753549 0.168499227931722 0.368969499386935 0 --0.286781442321581 0.175266285060492 0.102080880752403 0 --0.17125660024441 0.35858682527943 -0.30218577113806 3 --0.118824488875294 0.361563255376579 -0.321787320492532 3 -0.0122099078755344 -0.147969900347596 0.0316762949663718 0 --0.392551585221093 0.0510015277070673 -0.19073394938911 0 -0.0244584159305409 0.144322197356543 -0.376865157888604 0 -0.29243870395106 -0.0494164964591181 0.304738210265199 0 -0.175089515748451 0.0835703209831561 -0.156622212930059 0 -0.0890013198116806 0.305576534232025 0.288239168803326 0 -0.350119637595283 0.158307802174585 0.0499532087850503 0 --0.131899315608833 0.0497867060782768 -0.408600911606594 0 -0.20068115520861 0.397224771441976 -0.226646979560251 3 -0.451968070637465 0.213577645435825 -0.00351118238828818 3 -0.176052903418059 0.437530095821999 -0.162762667479629 3 -0.191632419379667 0.188442725119409 -0.348283914992607 0 -0.123613297326323 0.483920346880248 0.0193728219296994 3 --0.018285805571254 0.144379095522522 0.392496002188205 0 -0.068320603051699 -0.363770872910454 0.210339880682834 0 --0.227793124677722 0.379720308865093 0.0738976720168462 0 -0.169044020701242 0.122135260416533 -0.379124225195257 0 --0.259822980753155 -0.24111039187715 -0.0648442942512465 0 --0.10173609285279 0.249243356666994 0.249400585345437 0 -0.119629777301451 0.160847922465305 0.459893130865991 3 -0.0150258453172343 0.421377841825735 -0.00633979088126241 0 --0.0279863124691727 -0.342329441397124 -0.0896463534120024 0 -0.178503096062143 0.358806326824111 -0.166910002340348 0 -0.143948320967417 0.382006070173361 0.120615940925452 0 --0.171621978939983 -0.220121918181665 0.324262258934329 0 -0.0986077166277602 -0.384497308150317 0.302257505100078 3 -0.262518180186542 -0.340236291102196 -0.032005592389621 0 -0.0897899964130632 0.106574931718856 0.408459097761664 0 --0.190185487656798 0.197852167674855 -0.0095255130027313 0 --0.28999729594449 -0.316250649074078 0.0506532656287667 0 -0.150138221160625 0.160168950280297 -0.18735988865398 0 -0.395311691256455 0.0267029555947854 0.129561150832699 0 --0.0176794787247093 0.490737900274265 -0.0932660209924401 3 -0.128299082873569 0.475261538511496 -0.0848161238315203 3 --0.183717826655872 0.457273582870374 0.0807006789468117 3 -0.0426696008065371 -0.0898755589356086 0.382950573531753 0 -0.0736881865074663 -0.136449136248196 0.409312771502047 0 --0.0167458018839327 0.468176482706021 -0.175645401134662 3 -0.0133135968478466 -0.393562535720701 -0.124811950647255 0 -0.0961879527569645 0.394082920597075 -0.1920277059784 0 --0.0173312678767328 -0.358695585371963 -0.238433133864282 0 -0.104710310205417 0.311463185394762 -0.302530463326568 0 --0.176670066083203 -0.131045475070999 -0.382375118322729 0 --0.224345457048637 -0.298601386105704 0.0804830112890474 0 -0.0135149999999999 -0.40236 0.06374 0 --0.2278775 -0.0405424999999999 0.0456675 0 --0.27082825181428 -0.0457517836922444 -0.253274609907244 0 --0.061919950910598 0.177336583283246 0.326148905539805 0 --0.014795 0.21697 0.35959 0 -0.0689783751403615 -0.349262138395837 0.348073240146562 3 --0.0229880477840509 -0.308378257781288 -0.311792163352421 0 -0.32036 0.21996 0.00814999999999999 0 --0.34643471221522 -0.220332862224612 0.0413770895965792 0 --0.130404979558475 -0.0416975 0.408564455701855 0 --0.0581222777319342 -0.126980958176614 0.0933054847791986 0 -0.146993820055005 -0.283049639722259 -0.169284380106583 0 -0.397387687183217 0.157932697570007 -0.0162972823017439 0 -0.141570936248608 -0.353879555882222 -0.198583125000023 0 --0.0386538689074197 -0.187054172521388 -0.0246459250251497 0 -0.363098857153094 0.0456261839447346 -0.19802089165382 0 --0.22242448423636 -0.0397309209252277 0.313238814050217 0 -0.368747203311598 0.242692807983943 -0.0344562167667842 0 -0.0608127731074966 0.226666207561096 0.299205009332673 0 -0.429182671135529 0.0586414057020621 -0.243312552550105 3 -0.25661104696991 0.0258821669297596 0.293301411513166 0 --0.151035189928801 0.0472927099204296 -0.47427792870521 3 -0.0303466789930854 -0.159689590239449 -0.225034409717402 0 -0.073052356694822 -0.365986593772964 -0.148921453638052 0 -0.0288550376130945 -0.308015495043502 -0.392025171800823 3 --0.185648727870682 -0.400098122625737 -0.0385977313894167 0 -0.162962707338497 -0.241393413548681 -0.405321792175473 3 -0.03182 -0.357180799686783 0.190529618163192 0 -0.000793955201710439 -0.00545143111230612 -0.24225735610761 0 --0.117444232688596 -0.0016600029512851 -0.26719736639567 0 -0.0967272111090609 -0.0687270110791514 0.180270137768361 0 --0.0985466463535867 0.31888783039487 -0.243557039283552 0 -0.335376270230082 -0.0381917519458305 -0.0317853449441768 0 --0.141564751139838 0.214593194465553 0.0754162509640459 0 --0.175143339046439 0.237898538221625 0.284735380184523 0 --0.0977779535105947 0.148839091621797 0.302471509688517 0 -0.342098948657105 -0.36001537540721 -0.0359080210483625 3 -0.091357356694822 -0.335291593772964 0.212036453638052 0 -0.0313383854575633 0.210780925737033 -0.403428877275774 0 --0.00800527961922259 0.167429533068675 -0.257321797222827 0 --0.117822255011707 -0.356173674321982 0.327970100272079 3 --0.168194299002134 -0.259018176235783 0.0176819161536094 0 --0.185581820858327 0.261500041682136 0.381193903589217 3 --0.254627393237829 -0.0551618129236983 -0.422808953572466 3 --0.0216314467478202 -0.21545027786489 -0.451295334119774 3 -0.0421133572206355 0.24505203150394 -0.330608269487546 0 --0.0855300004832018 -0.208613759892039 0.0735933163795233 0 --0.204886062755162 -0.174185870572339 -0.229402981798593 0 -0.0268572880343453 -0.337299233515774 0.0762955636373631 0 --0.0610352690237279 -0.285911147012105 0.0937791430983969 0 --0.289444424440288 0.303542763534196 -0.117063219252544 0 -0.0108110664162594 0.392858401452905 -0.153096006464983 0 --0.206403450441559 0.211226064616276 0.215054362316176 0 --0.00830970359997574 0.413282257941416 -0.183883591506931 0 --0.0237294996085849 -0.332902127084006 -0.370547177764023 3 -0.257036057059889 0.289247089521469 0.158017720853576 0 --0.0803235220809815 0.157622697570007 -0.33775795933229 0 --0.0879808379388243 0.0156730822972753 0.138258157461065 0 --0.177923492312038 0.11547239909647 -0.297204248548704 0 --0.0787107305293489 -0.249665477011246 0.364257849670875 0 --0.255380331087359 0.182417738148038 0.288248529959091 0 --0.0930382663117456 -0.0174387983196144 -0.323167033138286 0 -0.142051085505327 0.180166730582913 -0.266272460071827 0 -0.0505753805016473 0.0251569707246748 -0.413649970377067 0 -0.0773796793463142 -0.218994150006135 -0.32695369908363 0 --0.0253059226090945 0.324476624771123 0.168041572838964 0 --0.0759946350377308 0.164688679549507 -0.000725201136114961 0 --0.0749144438025061 -0.156719713633968 0.470268764303496 3 -0.23321744583211 0.0588707846445907 -0.436429010063021 3 -0.083867180077815 0.212456084961092 0.367116285437787 0 -0.117152589986525 -0.234544078370366 -0.284778505152111 0 -0.291930738837164 -0.103403098442954 0.255304584018045 0 --0.103938905376232 0.453134979360005 -0.181709427613367 3 -0.00737867863686514 0.394145307061421 0.179849650872585 0 --0.0673558559676419 -0.321258830478392 -0.274208927081047 0 -0.431663225222448 -0.0591670046077728 -0.0125298830317473 0 -0.182074847240045 0.343604135017895 -0.312957716033269 3 --0.101763907067224 -0.44161827042688 0.210628511514347 3 -0.1055825 -0.295355 0.1727975 0 --0.20604829520383 -0.129688851010112 -0.139374018852266 0 -0.108676870491218 0.466533984068582 0.140821472440463 3 -0.0288067893707523 0.379250489257169 -0.103328771052221 0 -0.0173281097604204 -0.356221887362357 -0.349475794201382 3 --0.0420178530537079 0.0171372573666893 0.322264189654789 0 -0.186431763196337 -0.351694599656548 0.301261421821049 3 --0.197892453111841 -0.398649128242653 0.227226885485494 3 --0.155881258350555 -0.122905659214131 -0.100309086881524 0 --0.0756077826001459 0.251187288953941 0.359327674225141 0 --0.369311870108739 0.0848824267275994 -0.0504104728102752 0 -0.125046532499256 -0.480632242087459 -0.0561016482756909 3 --0.0209837470856492 -0.467379022150712 0.177427212711379 3 -0.0256598806282275 0.0652885623006952 0.495656477832226 3 -0.0793250000000001 0.2834 -0.0161975 0 -0.0887739294803649 -0.192325193780298 -0.398768207589387 0 -0.0676148288734024 0.112537157826937 0.240937779620778 0 --0.192708634840117 -0.145253578628008 0.364258690047797 0 --0.012722782184879 0.0693172357424345 -0.428796965262775 0 --0.174573696753619 -0.284803364571029 0.278854092593171 0 -0.155099572648509 0.36189013090625 0.000360631935167777 0 --0.134608368736561 -0.321286665123366 0.119424646103508 0 -0.159690053975604 -0.00363921368158338 0.2603870642253 0 --0.0702725564941263 0.366063947073414 0.0920090290716468 0 -0.409816610383699 0.105868124022575 0.112505066908597 0 --0.299490522183871 0.082074419264123 0.218245223238486 0 --0.0248983746865562 -0.161098074052129 -0.263724567332356 0 -0.0151511936086334 0.492913191101501 -0.0817658723543633 3 --0.352472181418658 -0.0501364255033269 0.254484255784384 0 --0.144897727617266 0.316165920663593 -0.237362158735927 0 -0.306106109889129 0.205577774500748 0.215711323322778 0 --0.0978875351240313 -0.247584490536482 0.136870643249167 0 --0.0425616602810573 -0.107901003949889 0.430316112016534 0 -0.150381187712984 0.0162300681795131 0.415257583716316 0 -0.00367221781512095 0.0615122357424345 -0.341001965262775 0 --0.0645282087850503 -0.185085302174585 0.307399637595283 0 --0.239432278029958 -0.323242477523785 -0.130607434345248 0 --0.404930168295266 0.22549249757956 -0.184031444701303 3 --0.0429399973977226 0.189681711917822 0.389817568578663 0 -0.213335508901234 0.360290619757015 0.069984565409603 0 -0.153327286175672 0.0407492123003749 -0.10043007962117 0 -0.272556715574692 -0.248121425144332 0.330709717837707 3 -0.145875 -0.04704875 -0.28306625 0 --0.0688489679070672 0.00145599079045522 -0.4958842837181 3 -0.0647377303475033 -0.0430461100648805 0.0747178532812193 0 --0.285000458866098 0.105273186959997 0.333606091517914 0 --0.110572904761199 -0.0687862043722935 -0.41157040725307 0 --0.00208604479828955 -0.239496431112306 -0.10580235610761 0 --0.2911554577231 0.229282374549708 0.203134297406419 0 --0.0208567125764499 0.14417677943613 0.0173587209589473 0 -0.1023375 -0.0699325 -0.25592 0 --0.363981451943598 0.337925638809486 -0.0333671165359098 3 -0.0326288897735247 0.0336677514784544 -0.498181732976581 3 --0.333862021747482 0.328331789988076 -0.171968493637592 3 -0.14767 -0.12353 -0.24281 0 -0.0881013866592071 -0.21357526746683 -0.0280794829523394 0 -0.124029449969234 -0.0465538623983635 -0.161900239714056 0 --0.288262565863116 -0.316747727791679 -0.0582318992330408 0 -0.1441825 0.03368 0.34218 0 --0.0901922619782671 0.441386791280643 0.216654548339425 3 -0.037723485973295 -0.184615670000584 0.386654405871661 0 --0.159700080367833 0.270214209480688 0.0241385959671071 0 --0.306186870108739 0.0431849267275994 0.0435170271897247 0 --0.0380093502667409 0.238565058122758 0.345451097396484 0 --0.164361425687291 -0.147921258538984 0.128684488264151 0 -0.163917980851552 -0.227178539746114 -0.339219661268259 0 --0.0325208866128647 0.387744310655868 0.226613380785036 0 --0.047243748982253 -0.294651271409714 -0.204737630122955 0 --0.0469249355061514 0.114655004082853 0.345578910535803 0 -0.25124398604721 0.200359680408465 -0.0214398910425568 0 -0.248308502433817 -0.186188481862425 -0.265049174173785 0 --0.0712579837779543 -0.363620266553892 0.229891001527667 0 -0.0949674351164154 0.109791803524164 0.0844575412061046 0 --0.0528845432253697 0.0708735845274377 -0.35991094492892 0 -0.026729175785959 0.167966369990952 0.470567512706136 3 -0.107760924024425 -0.396319408822231 0.16556134522364 0 --0.257500558165421 0.00255831559884345 0.23740249700982 0 -0.00170544583126975 0.19258836861985 0.370722508187122 0 --0.191997175648837 0.272193806109039 -0.284903374213358 0 --0.294336210090077 0.121505966745725 -0.292103000985983 0 --0.156247886048514 -0.378038301707262 -0.126280035821797 0 --0.179088323581596 0.0528858993165262 0.335496335922215 0 -0.0573693779819466 0.262999641299772 0.248786759758689 0 --0.0695754569565548 0.112087283481132 0.209566592666278 0 -0.278142655872423 -0.174351475742676 0.196006350773541 0 --0.234050588980311 0.379327168130208 -0.010345542901822 0 --0.0223911547100058 0.49044549483537 0.0937954083255559 3 --0.0696025042270538 0.244377550191646 -0.325615219179443 0 --0.112283704946853 0.213401440229965 0.348590680023704 0 -0.264594863925464 0.07930375 0.0702118698896188 0 -0.211933039640551 -0.244813090739853 -0.377733442695012 3 -0.296138869416017 0.00117543529228914 -0.278315685633023 0 --0.060139839366978 -0.339417282996683 0.0291630483272294 0 --0.162533646854504 -0.39282232998847 0.110211166817647 0 -0.359569346435175 -0.108585293515154 0.0540054223568739 0 -0.0311982517494915 -0.066121747278316 0.33526477767351 0 -0.0328709570730086 -0.330214045759359 -0.155446159665826 0 -0.22238160835843 -0.275199308516018 0.241351032070026 0 --0.0117007835987172 -0.17016732333423 -0.357544267080708 0 -0.216047835510834 0.0330979023705836 0.381210433757972 0 -0.0793140103462453 -0.342625606141519 -0.27392971318317 0 --0.133011641349273 0.0264429496582631 0.414182623662963 0 --0.24822125 -0.25386875 0.0280687500000001 0 --0.00519684025753653 -0.267087691403457 0.342058116464482 0 -0.28063045921349 0.146208866986771 -0.225036924625429 0 -0.176336007962772 0.103470374983503 -0.231710951072004 0 --0.11348625 0.21201375 -0.02866 0 --0.422162550481038 0.0416308693006969 0.0264754859384234 0 --0.392883487244525 0.171113848246979 -0.0263238384112358 0 -0.294330348507705 -0.0820990965932862 0.0864189408297307 0 --0.0596164443104307 0.199462129007781 0.0696246306258741 0 --0.0212326416724057 -0.178003005180195 0.299797881329927 0 --0.0583102354018099 -0.285513087535393 0.178793335398001 0 -0.0653572483399947 -0.0985907161059144 0.331636284374321 0 --0.103455505515301 -0.278859815887985 0.0391179443902145 0 --0.118461370274134 -0.28560109745097 -0.28875679685892 0 --0.0701361870783007 -0.0611761819515781 0.222375622013132 0 --0.100355111118195 0.263169910759788 0.00857984600537676 0 -0.121306270294546 0.302933504176256 0.060259629842278 0 -0.0176173228561429 0.211602045214318 0.0762034381623566 0 --0.0468134006029067 0.303668538866378 0.22779792858942 0 -0.0424321051110542 -0.186793824746677 0.157916460675192 0 -0.228675669991175 -0.25943422083936 -0.162581577909304 0 -0.0223618996196862 -0.123642023948566 0.438803960898267 0 -0.0296536309192694 0.227601957928459 0.353833404910211 0 --0.103524652460043 0.208509087551956 0.404842049659549 0 --0.337846046030482 0.24289717850615 -0.0141611007548834 0 -0.0292171549334719 0.00700592104829734 0.362124205984026 0 -0.305176752979028 0.328908983014795 0.219323780164563 3 --0.246799003383107 0.0242165128218021 -0.43032560741969 3 -0.0166320408856681 0.424060038191355 0.2663334216501 3 --0.0363281873196584 -0.274491364482905 -0.284507103453275 0 -0.0681431824417867 -0.283971011353254 -0.289376401580358 0 --0.117389678208361 -0.145823943506197 0.312260617448033 0 -0.0621749591903235 -0.425751226832728 -0.0888165247626908 0 --0.0321106671515773 0.248417199712497 0.43332393552249 3 --0.186423629366008 -0.339910219557599 -0.314311590546748 3 -0.00568324641701312 0.0935650639876584 0.300575737500955 0 --0.0129040382428098 -0.141484660660635 -0.4796495281026 3 -0.103871615666177 0.407011059820432 0.0525340970561848 0 -0.0266238709272555 0.255868173627377 -0.429160454626423 3 --0.0595207575209145 -0.396754803839277 0.104819728380906 0 --0.110549989264147 -0.359530753263442 -0.20957923166045 0 --0.22024678380691 -0.0473691521757471 -0.358859521396488 0 --0.1472426123604 0.310125062015246 0.26230186537537 0 --0.04339975682155 0.419928169662035 -0.00715014329188185 0 -0.419792987479434 -0.0351738247510867 0.157939277573788 0 -0.0617165012787246 0.19491612843777 -0.276019181630121 0 --0.0522565073055368 0.275290682559134 -0.250629583992809 0 --0.0968724795584752 0.0384800000000001 0.378099455701855 0 --0.0268063722643674 0.322496442052581 0.275512713915801 0 -0.115652439977842 -0.435456409661425 0.0433668798044105 0 -0.058645355746578 -0.151342249780342 0.249628104685301 0 -0.076723109982921 0.11600426997786 0.168583756126083 0 -0.0684263843406228 -0.018747592910112 -0.106336417489928 0 --0.0206666947228943 0.295671998221247 -0.273879221876292 0 -0.0265907335618381 -0.485521167061059 0.116013055044413 3 -0.117499984797691 0.00796612326916657 0.0915090401012888 0 --0.234070158076753 -0.138109669783038 0.414372227301689 3 --0.135093659966763 -0.406522114492138 0.0256896899022052 0 -0.15815831685006 0.117864975143051 -0.312657597785986 0 -0.110855 0.0957425000000001 -0.3209775 0 --0.339137777034485 0.258186316252381 0.253217496210694 3 -0.230206924917917 -0.298741970583924 0.0845560497610269 0 -0.195723567203571 0.237189650323445 0.39176534357366 3 --0.344157025914103 -0.0227114727265452 -0.251540146144358 0 -0.164044011756426 -0.377261218240077 -0.136321289843259 0 --0.115682836162848 0.361637023594494 -0.0951444809507179 0 -0.382893914432119 -0.05916 -0.0898853105206349 0 --0.0564718788401763 -0.427835605552126 0.015055581309814 0 -0.0922008025526755 0.0225206763437406 0.154118867834469 0 -0.0606020427965323 0.197269299802281 -0.366599109997326 0 -0.117067758561261 0.136757191152631 0.239633601411836 0 --0.18847379806667 0.408096408363671 0.217168438272614 3 --0.354985779090795 -0.344740502538389 -0.0545790416152915 3 -0.187345653917709 -0.0250599817597686 0.347787867432625 0 -0.21469690905857 0.0419508680509109 0.172572293004697 0 -0.00427694910000609 -0.325649214524506 0.155517820606334 0 -0.117328429405356 0.239979063495786 -0.192042933006874 0 --0.060515850899192 -0.0507758106409842 -0.42813125308754 0 -0.229619694996228 0.153078979893587 -0.411412678498389 3 --0.301822463520631 -0.0966690217111819 0.119959211470037 0 --0.0292883806117843 0.305937744290052 -0.39378072858006 3 -0.175424475054046 -0.219232571442132 0.344987136323926 0 --0.0254809571420158 0.240299263747445 -0.373742154563098 0 -0.245403612826133 -0.233331114937005 0.192117393036237 0 -0.336351490863746 0.266940541883045 -0.248553246255718 3 --0.055774325380607 -0.00836232992004565 -0.285374181634354 0 -0.375500151503876 0.0493308658203429 -0.0833125339173724 0 -0.151130612752212 -0.0631246774447734 0.305587930642676 0 -0.388436698511094 -0.26965287401338 -0.160137095682612 3 -0.00213081526798087 0.316754290050566 0.0404228445288246 0 -0.00665408580149662 -0.165426877223268 -0.284445811594159 0 -0.02766 -0.2163525 0.217515 0 -0.0633997715389937 -0.0149923461347451 0.31801114940423 0 --0.00226406427675713 -0.377116227273939 -0.195511851438948 0 --0.116776007179871 0.323682966646489 0.0595618248360295 0 -0.115153251164851 0.325527919521492 -0.202470234003632 0 --0.010892773306481 0.359738781011956 0.240239682164851 0 --0.136732470143996 0.23127108794659 -0.165840651672092 0 -0.01591 -0.4235975 0.1541975 0 --0.00128 0.23462 0.14382 0 --0.29766059568773 0.0292445409993315 0.155998865456459 0 --0.33483921756772 0.0609859148832315 -0.124403804590235 0 -0.110849941943649 -0.486644434567113 0.0255289934280666 3 --0.0140115558231361 0.33856013326929 -0.038972259446048 0 --0.102792704825703 -0.158845533724419 0.208810856546299 0 -0.0420635904193067 -0.347206247688386 -0.259350088448725 0 -0.144757813754476 0.0326500330321957 0.0400754006302515 0 -0.2231084795717 0.16074642639707 -0.188136729791216 0 -0.0342163910924396 0.245881382128783 0.0751297326313873 0 -0.29640957059578 -0.250894767583491 -0.216145786700808 0 --0.0146136503587171 0.437325576039969 0.244324006472192 3 --0.0307162388908724 0.377309937672474 -0.0615906824220334 0 --0.057797902078602 -0.0198533969010817 -0.357254302536611 0 -0.161466076342043 -0.292738889169264 -0.110138658449088 0 --0.0755358678034624 0.266350269747543 0.416838385212857 3 -0.0751975368250283 0.384179522445774 0.239026130077726 0 -0.105450276307893 0.0188185631551288 0.304701251919009 0 --0.111760369752739 0.281811642583701 0.324013434185715 0 --0.016842530296758 -0.0211170260511225 0.446942693842598 0 --0.0237097264539349 -0.490379442425106 -0.0937538764015765 3 -0.178887168062438 0.230798861893127 0.167961998200805 0 --0.00412135323095991 -0.423669224861124 -0.0107473495441439 0 -0.0167216032875285 -0.448434873462384 0.223211584141609 3 --0.146626876170174 0.119728163412055 0.0589940480310712 0 --0.323424943383066 0.109180512992831 0.010784829691829 0 -0.0161538907493938 0.230321463668361 0.268536237542057 0 --0.224617655612272 0.115345313387928 0.0334087808129668 0 --0.388497357621837 0.0372901825577647 0.175943026618385 0 --0.0316486859704393 -0.250350923399576 0.432126048241554 3 -0.354135093208904 -0.0471435943729193 -0.225140922801918 0 --0.380030568585803 -0.042184445819006 -0.172639498310539 0 -0.207517284557897 -0.0150491996582631 -0.394524912241386 0 --0.283454549101855 0.351352249783662 -0.214565519837927 3 -0.318730069894684 0.285000044114726 -0.0616310285616071 0 --0.0572329934894693 0.125397166022146 -0.169659199238804 0 -0.0537436926381623 -0.313413905070252 0.247718465885135 0 --0.01057 -0.0964375 0.0824050000000001 0 --0.148588719023091 0.194813650185805 -0.351341824259703 0 -0.0245074314328855 -0.313805459202571 -0.313242257184526 0 --0.119610596062142 0.410246326824111 -0.0215037523403481 0 --0.172066713758564 -0.350405430163466 0.31110376108064 3 --0.226602193503251 -0.0447942382634074 0.441603046976449 3 -0.0298853092700814 0.324234909932287 -0.187539188376218 0 -0.0699846492949954 -0.043925224108989 -0.493761819161074 3 --0.00700802239914478 -0.0839919655561531 -0.0014311780538051 0 --0.233970475308609 -0.134159752949429 -0.415476886210985 3 --0.199406991974537 0.362329625373053 0.129503369539895 0 --0.218768487733094 0.0885349109647902 0.263265374917367 0 --0.326300491667442 0.109437782267928 -0.202291743811252 0 -0.141870961577813 0.0640639914030121 0.475835800242545 3 -0.335368755648224 -0.36574915001176 0.042169450684389 3 -0.0932387499999999 -0.14626 0.2906175 0 --0.0426251587428756 0.4050459154922 0.174578538910938 0 --0.0748298160632228 0.354863486616263 -0.255485476006345 0 --0.0280730302831926 -0.188107706707022 -0.099312507537379 0 -0.0606902466635004 -0.0142317373530244 -0.225851387230742 0 -0.02711 0.1203775 -0.0747225 0 --0.431090390756224 0.0424412133637997 -0.0686727159636128 0 -0.285883513818767 -0.0981119462139305 -0.00522934101782563 0 -0.0537578139464742 0.36004396454921 -0.0466251948488794 0 --0.193230441813659 0.454640741935671 -0.0739565421047331 3 -0.0751770895965792 -0.287057862224612 0.26822471221522 0 -0.124871306534556 -0.359255810195834 -0.322258545468527 3 -0.157479973733575 0.225119931290562 0.0807792126245345 0 -0.0188261642570183 -0.493302163917942 -0.0782903146366823 3 -0.0165459398411095 0.488016807143537 0.106852307407686 3 -0.134043614358165 0.343542962118559 -0.335463015673142 3 --0.0504451289086704 0.305762578247266 0.315814552158535 0 -0.0112730282568958 0.348233092888264 -0.357851861750366 3 --0.133231409973079 -0.253292099963713 -0.0623394990260683 0 --0.232330009836051 -0.119250731991747 0.172307933848825 0 --0.0436163819609499 -0.194223295923608 0.385005877764444 0 --0.0164450014709561 -0.164764002953466 0.471999790099301 3 -0.0337585658669399 -0.0801069064406098 -0.314242922901448 0 --0.0243634113162464 0.237733724436453 -0.439428908533832 3 -0.0570919776008552 -0.190069465556153 -0.117617428053805 0 -0.273483952191509 -0.0024084796375855 0.0304681548650492 0 -0.033579854579202 0.329375602750234 -0.3727194596889 3 --0.0815583865566374 0.421400746987821 0.152129522529393 0 -0.0504532329041794 0.31427730688765 0.117126360124521 0 -0.160563927991272 0.418147776587322 0.0588070850337261 0 -0.399260496192642 0.127606927304005 -0.115555136258376 0 --0.433162329545911 0.0544606349384228 0.237360007034378 3 -0.313200478668789 0.107591983543227 -0.261836167213492 0 --0.0043672103953688 0.249475971162917 -0.366151699179122 0 --0.126660635854553 0.480049404751507 0.0570790261622097 3 -0.357586622847782 0.345974540972336 -0.016570304808236 3 -0.0281575510083563 0.309858572602924 0.325614130560284 0 -0.264716062486005 0.301538211867344 -0.00307571802833978 0 -0.033354085606131 -0.166679588848031 0.470784093499562 3 --0.054693678347411 0.336511196729874 0.181373035900622 0 -0.422881981612696 0.061062733639354 0.0611123533733243 0 --0.0622813858256783 0.185659369249374 0.208958289577935 0 --0.252317711600424 0.242480274630777 0.350648897122897 3 --0.0539043963964852 -0.265443627330477 0.336351621006357 0 -0.147095226699737 -0.185735574828365 0.262825184059372 0 -0.0468590232057856 0.373418544573636 -0.233039800910498 0 -0.277120250883954 0.137215252512462 0.247872354841052 0 -0.275046403269366 -0.196546377365931 0.115599269993523 0 --0.0784007763801458 -0.356107905034737 -0.33915869846387 3 --0.0302548868380543 -0.333001236185213 0.105419091078199 0 -0.257567508735084 -0.309737832334747 0.143989727433429 0 --0.121306239298882 0.140696938919673 0.161231974423055 0 --0.178299107631402 0.118090716986877 0.217165952431503 0 -0.18804375187817 0.247380365884381 -0.307085502093004 0 --0.0878272123690018 -0.288074334002083 -0.296103092705441 0 --0.0544745376029032 0.431963840924381 -0.0824622989335808 0 --0.0720690510653596 0.194940428200866 -0.456295035144145 3 -0.0942037016662177 0.300166436285283 -0.139178334829666 0 -0.0239287179453647 0.237391406620544 0.160752294369499 0 -0.334412611418412 -0.234966147647465 0.277948570839622 3 --0.0911497264332392 -0.0275794494120976 0.431575276773894 0 -0.131017177906506 0.413734963548587 -0.0758640759852863 0 -0.0168199699162936 0.466035559840366 0.181479786189817 3 --0.173210675758967 0.249122895955725 0.119197361522243 0 -0.33325479586016 -0.28382970419261 0.0201160571681732 0 --0.365458617462069 0.175209993178814 -0.159932633909245 0 --0.151441492524583 -0.170898612451432 0.0562400830804768 0 --0.23525688204368 0.332624742458255 0.152829822312965 0 -0.342811867106297 0.053547429116515 0.00899322485071741 0 --0.075024133971995 -0.207910579555547 -0.125197719517123 0 --0.0580142159813128 0.244348731813208 0.274253114968537 0 -0.0119435690330665 -0.378689676684806 0.232554598410809 0 -0.192502034540317 0.331615851640772 -0.0721484277898783 0 -0.0724958512219755 0.00157388764697564 -0.411815842932597 0 -0.0111154251491846 -0.300473846212149 -0.399262497978594 3 --0.175944484218455 0.440603298603203 0.15437778562903 3 -0.0217937808981231 0.37193139664082 0.032943956415632 0 --0.0131409449857741 0.288841351273287 -0.407810302448395 3 +1148 +0.181649679650292 0.183792388025941 -0.42648950113624 1 +-0.00404591900913237 0.17957701473483 -0.466692169494293 1 +0.0448127505568419 0.143312400696681 -0.306813764173762 1 +-0.00741587508907693 0.277754822651356 -0.41559010779055 1 +-0.0106993403244344 -0.013356330765348 -0.49976019918158 1 +0.317230357805899 0.0128403108242126 -0.386456956496315 1 +0.215571351581475 0.398957341576902 -0.209235199103998 1 +0.000505989490886649 0.386536405513141 -0.314986421888764 1 +0.2036118314453 -0.082358653787893 -0.24099483316372 1 +-0.182163274276144 0.170468409107021 -0.431802086626473 1 +0.169458679252729 -0.163283490816276 -0.440784089011374 1 +0.0158575823011274 -0.132151523988646 -0.48213656612606 1 +0.436664268341584 0.180346367283509 -0.163697140175315 1 +0.0748670521054756 -0.153943728706926 -0.23720282522245 1 +0.00369469100984054 0.473087272432698 -0.161937577923134 1 +0.02703 0.32919 -0.02703 1 +0.240311066385381 0.128329760862882 0.020391528354318 1 +-0.181754768592537 0.0254241394763848 -0.206510558857109 1 +0.265803754731452 -0.124544673753292 -0.113342930264044 1 +-0.215519996947362 0.406232116343012 -0.194358368733851 1 +-0.150595368152419 -0.187640058476799 -0.439069549421146 1 +-0.15347649306112 0.279539080781306 -0.0729988273295592 1 +0.0243100000000001 0.00670999999999999 0.0140400000000001 1 +0.00213623524504891 -0.288835350324339 -0.408166223327136 1 +0.301769637501113 0.397755608130862 0.00318378000090191 1 +0.409627689430281 0.286611562953166 -0.00531597388688526 1 +0.153507840536577 0.475813715911632 -0.00366823606694766 1 +0.429288954556914 -0.175351866355422 -0.183196526302751 1 +0.490728790002483 0.0960575149592203 -0.00254492714812127 1 +-0.00406594899472923 0.498691826704812 -0.0352483796910545 1 +-0.385240795754914 0.00611923570011486 -0.318901061844752 1 +0.499820969324789 -0.0158350585792909 -0.00019288682467844 1 +-0.0598301202034775 0.227978101433416 0.115999412323565 1 +0.203717398427135 -0.407800549337424 -0.203461068945105 1 +-0.158994762563513 0.474036526805511 -0.000205690343791864 1 +-0.314135961637385 0.197319233065886 -0.0195995010885988 1 +0.00539333707518652 -0.409184022040807 -0.287672622656401 1 +0.485082471941015 -0.121518666741412 0.000398729982617474 1 +-0.11877 -0.22043 0.00251000000000001 1 +-0.429727455390994 0.174390978814557 -0.183456401617927 1 +0.428098083994196 0.182244273033587 0.179894975424465 1 +0.02703 -0.32919 -0.02703 1 +-0.333747418426155 0.369923940554775 -0.00237151641211808 1 +0.231752195240157 -0.0390710842034035 0.187065737595179 1 +0.00377263168541364 0.481731638453373 0.133601577574257 1 +0.400824943715283 -0.29876761297621 0.00566522715353912 1 +0.203382845770448 0.412183904372729 0.194430759401801 1 +-0.209788497697802 -0.409013839302819 -0.194499624869438 1 +-0.302108126499832 -0.11977442703841 0.00398239974316839 1 +-0.402842517130148 0.295767804265477 -0.0126476620942963 1 +-0.00423967469505609 -0.480512872140484 -0.137801146886325 1 +0.3253534227853 -0.377374586979218 0.00923844023055109 1 +0.06364 -0.2678 0.15326 1 +-0.426929309126968 -0.174718921115105 -0.188474381257813 1 +0.417926850081159 -0.203222525687497 0.180360790751317 1 +-0.18403 0.01387 0.21199 1 +-0.483150581178465 0.129005675353026 -0.00430744239976133 1 +-0.0291566733363567 0.125970861096642 0.325534599100347 1 +0.00505629129209473 0.40580731214294 0.291889851116207 1 +0.153650038438378 -0.475767648195599 -0.00153991127538289 1 +-0.214034261459554 0.403920213594896 0.200637483554921 1 +-0.498763537402931 -0.0368377555739939 0.00282022617445921 1 +0.384224583135308 -0.00410020833711905 0.320222390585786 1 +-0.00290458196997806 -0.498106275930081 0.0429370596261022 1 +0.02787 -0.17874 0.29903 1 +-0.484014991666471 -0.125501841522086 -0.00663173027703873 1 +-0.431635104125934 0.196789256151435 0.158005068782339 1 +-0.161268804039044 -0.473329671522244 -0.00296145089000566 1 +-0.404952950888742 -0.292814487269573 -0.0142666437154391 1 +-0.305451736614801 -0.394294600996444 0.0179170350256947 1 +-0.00692073513028352 0.262986685613512 0.425234230356829 1 +0.192218697370777 0.153266778797823 0.433514048056483 1 +0.224018309283775 -0.400741058027008 0.196401925801936 1 +-0.00583210488023289 -0.480048261277519 0.139510344268284 1 +-0.432665066228349 -0.185838534129751 0.166859818777745 1 +-0.0101218875916336 0.172215976807165 0.469372688559606 1 +-0.198250977311677 0.162003290737155 0.42713106621193 1 +0.182871313096183 -0.158262873368293 0.436181269323578 1 +0.0138715893742679 -0.397261098952254 0.302208506526635 1 +-0.224015363440137 -0.386539253152673 0.223788924142595 1 +-0.316167298156711 -0.0173685356884946 0.387078445268525 1 +0.00182103326769112 0.00805119342532934 0.499970680829952 1 +-0.0190149309802295 -0.264856126290839 0.423720241343349 1 +-0.0125210383248142 -0.167335759202051 0.471119404942234 1 +-0.190385042822908 -0.172027153912213 0.427152759592249 1 +0.467964573012229 -0.161408541405809 -0.0806601316346454 1 +0.430445841189107 -0.241764875690935 -0.0854255577829313 1 +0.462625903271351 -0.168558246853113 0.0946823774762898 1 +0.413314821737564 -0.265548370606172 0.0945848641168483 1 +0.0815895132429152 -0.14837371059857 0.472195899968348 1 +0.077109526870119 -0.217274344603184 0.44543201972089 1 +-0.110285850614934 -0.159778387392349 0.462151594551915 1 +-0.101906376932727 -0.235205256523095 0.43029949539521 1 +-0.0743817347160882 -0.150679627653036 -0.472548333630983 1 +-0.0804568389234837 -0.243011022025905 -0.430897632258721 1 +0.0979190625036158 -0.13637839943232 -0.472520151143943 1 +0.0783926523589478 -0.220564882451696 -0.443367950708682 1 +-0.465759635209826 -0.167425095550446 0.081259895636571 1 +-0.426637951459407 -0.252388585438368 0.0726070076533892 1 +-0.46438353695746 -0.160880861876766 -0.0992372076565855 1 +-0.419499479224069 -0.25013628234176 -0.108998935476277 1 +0.0936268125867814 0.160301236295355 -0.465758787028261 1 +0.0894326676157386 0.245062486702005 -0.427642527009924 1 +-0.0988191589540467 0.153291673955308 -0.467243579651986 1 +-0.0929472700721024 0.238643910225642 -0.430701278957817 1 +0.46859446876128 0.152418671468134 0.0927741652452212 1 +0.430301865351154 0.243909716593481 0.0792084002144702 1 +0.474379992626933 0.139187759267253 -0.0845151868380198 1 +0.439865173381558 0.228530593572637 -0.0757415523062144 1 +-0.464302581119678 0.166221728923169 -0.0905725498401531 1 +-0.429060891099808 0.239022115677508 -0.0980519467970043 1 +-0.465512569221144 0.163646479783047 0.0900821715607691 1 +-0.424984998958637 0.252503378200201 0.0808553176268635 1 +-0.111170261612425 0.145843511106251 0.466585390221259 1 +-0.105972622331853 0.225167483751478 0.434786194121578 1 +0.106202035896927 0.157911611845847 0.464033632448849 1 +0.0721674284399241 0.238003347931369 0.435249152141001 1 +0.0862864296484287 -0.48434442091371 -0.0877392137397727 1 +0.0860765805197719 -0.48594977299695 0.0787151443518 1 +-0.103489035090003 -0.481935538292892 -0.082121446002265 1 +-0.0960840648332446 -0.480767089494016 0.0965379921101172 1 +0.0872229705757069 0.48381199434664 -0.0895901079125004 1 +-0.0899553830502568 0.483711199837137 -0.0875205624827633 1 +0.0945105209720999 0.483333503253623 0.0848028511991888 1 +-0.0856979163570546 0.48509930592363 0.0840542911869392 1 +0.0409740419338982 0.0786388081611582 -0.493590755587285 1 +-0.488244754878355 0.0882911246596388 -0.0719582218737017 1 +0.490523183617217 -0.0721922719462236 -0.0738223177106462 1 +-0.0706733045969329 -0.0721348836950246 -0.491034807262518 1 +0.492171717106509 0.0635788907454646 0.0687053666690113 1 +-0.0745479700436116 0.0762956637772385 0.489716838655559 1 +0.048031499446364 -0.0806250927479578 0.492455646477826 1 +-0.489434243984812 -0.0789070844503309 0.0749169269292568 1 +0.491850082272879 0.0565889720663871 -0.0765873537504795 1 +0.0714884477991682 0.0846407521510998 0.489147737171373 1 +-0.0545077460784956 0.0829973691274366 -0.491739031013079 1 +-0.487258479502224 0.0854273374568583 0.0822786611848152 1 +0.0664869784838834 -0.0658784799582574 -0.492212330980857 1 +-0.0871883322200059 -0.0991705470516572 0.483713541329434 1 +0.486811454527176 -0.0871865894178329 0.0817404487885471 1 +-0.489470809347246 -0.0811168605440311 -0.0710490699994507 1 +0.0876900644691113 0.333660427062734 -0.358997934912503 1 +-0.36910357357846 0.319065934857098 -0.0994360212703349 1 +0.367855664662202 -0.326018449838828 -0.0801906414949402 1 +-0.0964338298031557 -0.307714730746907 -0.379709193824914 1 +0.35959021231319 0.335176917436905 0.0792872226582969 1 +-0.0960756295048938 0.300402717685164 0.385633305368482 1 +0.0560920463197608 -0.291841636003494 0.400870326323965 1 +-0.361151384836894 -0.333599910484472 0.0794233822479538 1 +0.103012017262897 -0.456569750841577 -0.173271904375817 1 +0.184532108131506 -0.452736684309291 -0.100580913403009 1 +0.175329909114952 0.454428856637334 -0.108699658970125 1 +0.109723637893704 0.45165484752224 -0.181739428199267 1 +-0.0956244412938786 0.32816387880713 -0.362062995193675 1 +0.384004154419913 0.302078578053779 -0.0972686584318069 1 +0.354894495574859 -0.337356163424792 0.0906202618021581 1 +-0.105221408821649 -0.317069001436945 0.369204811086815 1 +-0.360674486630194 0.329458603092328 0.0963579882071455 1 +0.099336913176225 0.30807682880688 0.378536723385096 1 +0.0954445616435136 -0.298251633727299 -0.38751839066719 1 +-0.356317400224007 -0.330117765160665 -0.10956074701543 1 +0.103736962526507 -0.455361695623678 0.176088911793781 1 +0.17950932785754 -0.456747142142507 0.0916325818203929 1 +-0.196328029838178 -0.448274761429262 -0.0986697475970014 1 +-0.106461097096722 -0.457234320338963 -0.169437271719776 1 +-0.192808859514773 0.448627591579211 -0.103389569220106 1 +-0.10346158393126 0.454008814925692 -0.179663865546562 1 +0.102215893361395 0.459179182665086 0.166791386206993 1 +0.185800659745604 0.452588028958527 0.0990203803144166 1 +0.28642228573444 -0.395839424635671 -0.103377177352853 1 +0.248428375344986 -0.435267963886189 -0.00184216137776994 1 +0.281080105623768 -0.398572689913212 0.107981338055151 1 +0.102004194548682 -0.417524131260802 0.25574101003247 1 +-0.00658181410689629 -0.445988017884987 0.228653412238067 1 +-0.103056692662831 -0.39693591460115 0.285043685968045 1 +-0.114938314637416 -0.44641235445779 0.191231790497177 1 +-0.102679849968955 -0.41501147142951 -0.259228023911176 1 +0.00887360238809498 -0.449374466108321 -0.221698288195131 1 +0.103611222369838 -0.413210370416399 -0.261838944493521 1 +-0.273969513284499 -0.401845835929191 0.114180674986732 1 +-0.236245679881432 -0.442066404760651 0.0013194543551337 1 +-0.184815182843482 -0.452221645398577 0.102340642559394 1 +-0.279735975046357 -0.402551447212746 -0.0966240611304217 1 +0.110223768148164 0.404107893715381 -0.272396475963525 1 +-0.00346440207846965 0.439699279636626 -0.240540386590157 1 +-0.107451125146787 0.40475678912766 -0.272722362450075 1 +0.279305029277906 0.401889115358443 0.100293389735775 1 +0.230217500774445 0.445264478128076 -0.00103795726393324 1 +0.267168324116808 0.410420843413159 -0.100743859038693 1 +-0.293557588559925 0.388909830898888 -0.108515880914591 1 +-0.254668796443513 0.431539732690689 -0.00334693075880238 1 +-0.281162568025937 0.400385455992697 0.100768921711759 1 +-0.183119462276981 0.454480746883579 0.095338137932854 1 +-0.104183356071395 0.417399807876378 0.255121657617619 1 +0.00980289090982112 0.447578028425933 0.225371242612943 1 +-0.0944945163679088 0.457441348961681 0.176051971938103 1 +0.108682382514004 0.419345076946862 0.249898771932541 1 +0.188531798626738 0.012982774688456 -0.461126170916431 1 +0.454570952223381 -0.0104160167543128 0.203160644378992 1 +0.440681881991681 -0.0109745907851164 -0.228444059184899 1 +0.218079539005047 0.00482425500961181 0.4462722798504 1 +-0.457783418444363 0.000122551483372924 -0.196549152254095 1 +-0.203790334025063 -0.009673182616531 0.45434170163472 1 +-0.229428162896912 0.000445912001227677 -0.440327925891568 1 +-0.449210000926725 0.00511155123253504 0.212480786617677 1 +0.20377266219075 -0.299647543938693 0.342619325684997 1 +-0.323446688009779 -0.334954241756417 0.180034520701274 1 +-0.318891810878822 0.331892991792246 -0.193398651610915 1 +-0.241365032321625 0.28077335592792 0.332744478130537 1 +-0.360093556382741 -0.272937178687081 -0.210131386307048 1 +0.200328313774447 0.289507175214499 0.353197098000787 1 +0.20271768717168 0.332678010386557 -0.312135838198167 1 +0.315193878310361 0.327886868655742 0.205648683059131 1 +0.332418751260496 -0.327748225440895 -0.176818930651406 1 +-0.224254853786075 -0.28617016516295 -0.340347372176796 1 +0.230238839976246 -0.273717127185425 -0.346106304375547 1 +0.334482317988915 -0.175310720594061 -0.315522113613716 1 +0.35665468701069 0.292391273962805 -0.190243650793152 1 +0.34622144915584 0.190002824097871 -0.293956171002104 1 +-0.190062962179971 0.315010362057436 -0.337086770889593 1 +-0.309652138320663 0.338540993891117 0.196770939403175 1 +0.347063502492934 -0.308089748822491 0.183574107742143 1 +-0.198562801554303 -0.329477173805962 0.318154466836844 1 +-0.338128474189522 -0.200769895000932 0.296237266928246 1 +0.294896600976598 -0.217247870495804 0.329499848253443 1 +0.256757438488155 0.101652201634692 -0.414832273487505 1 +0.247256843409607 -0.0754259922893191 -0.426806109495472 1 +0.406566369309519 0.0797550866072929 -0.274476389504019 1 +0.418325657900833 0.0932674838165378 0.254781491598445 1 +0.413847841669437 -0.0936679721132727 0.261457310143361 1 +0.279744583301236 -0.129140307326265 0.388213375427329 1 +0.266156480867235 0.100829734565039 0.407160462987818 1 +0.307668957059109 0.174093180700507 0.342436902213158 1 +-0.422628854856476 0.084103022809908 -0.251322025645131 1 +-0.424705669432303 -0.0824852216973794 -0.248473123200992 1 +-0.316417285332005 0.182126677423033 -0.329671174750531 1 +-0.265837652292333 0.100373092746321 -0.407527674814902 1 +-0.268331635526014 -0.0946354653331551 -0.407220084497297 1 +-0.310830309606375 -0.169243297171728 -0.34215030450121 1 +-0.263212378499946 0.0777773238159404 0.416449269523141 1 +-0.255800434188143 -0.103424259586768 0.414877147122284 1 +-0.343382272053969 0.171163733068103 0.30836660144391 1 +-0.406046320336448 0.090289202847739 0.271703120148694 1 +-0.411436781321103 -0.119284657419713 0.25153411650659 1 +0.399655817105665 -0.112318842306573 -0.272214587201097 1 +0.152046786725245 0.23384462660792 0.413626463409061 1 +0.158224281321722 -0.0666723997807652 -0.469812954267704 1 +0.17031885214733 0.0854430500058579 0.462149583402085 1 +0.462584223081124 0.082499557640046 -0.170581557704235 1 +-0.468353146446449 -0.0775662154782868 -0.157936015318218 1 +-0.164575517062789 -0.0877131365454801 0.464027126907379 1 +-0.169404588564884 0.0833806880178636 -0.462794824082798 1 +-0.459706533403675 0.0909515918109666 0.173218733041941 1 +-0.16034993451908 -0.0831498833960812 -0.466612333975207 1 +0.361734441939613 -0.231007890337413 -0.245722305750724 1 +0.263035102906758 0.221973907421482 -0.354228007887306 1 +0.227651539524292 -0.211916355814515 0.385156768694144 1 +0.256009532890385 0.013605340748726 -0.428713246787611 1 +0.339360006281035 0.106147273633889 -0.346295968403052 1 +0.426118290984761 -0.00265447335973351 0.260910486888071 1 +0.368613757820606 -0.18948750764629 0.267739493393725 1 +0.352244552528266 0.0916872613578014 0.338253052262498 1 +-0.427430458790053 0.00621334865275025 -0.25861102310763 1 +-0.352011991935335 0.0968061405379521 -0.336709585248964 1 +-0.308969432830388 0.00509323128817674 -0.389932224649517 1 +-0.375213636232456 -0.164623671672833 -0.27528371360425 1 +-0.260990132398831 -0.0141483175746636 0.425726102121592 1 +-0.337195836582654 0.0820684036266049 0.355943642623786 1 +-0.391904475120323 -0.00920859670021257 0.306206311969713 1 +-0.266489883698266 -0.213927107198002 0.356077854457375 1 +-0.379516105556075 0.174078792751539 -0.263494854325929 1 +-0.277832370004858 0.185288091103271 0.362744960085771 1 +0.25396086063463 -0.177295569692176 -0.384947601969625 1 +0.459979579240587 -0.0936548919658454 -0.171592311561185 1 +-0.269847207629412 -0.326989438228978 -0.262472240612371 1 +0.238303637366938 0.208758969959514 0.379581676450743 1 +-0.375015652034787 -0.232608065519975 0.225283732631697 1 +0.14695343276534 0.0943575515634417 -0.469479661293052 1 +0.0956249048252545 0.00489303094899873 -0.491066332273753 1 +0.468211617642153 0.0823689663327973 0.156318703341738 1 +0.486776873944676 -0.0107802485093045 0.114100610417981 1 +0.483578394983017 -0.00932067408048609 -0.126764041494552 1 +0.15433287745145 -0.0755588587069934 0.470213929285137 1 +0.116300183553799 0.00818203947961604 0.486421633806221 1 +-0.465738657238433 0.0871990239746697 -0.160712777837768 1 +-0.491487511058316 0.00427913960562576 -0.0936140318601432 1 +-0.169282353463571 0.0733627236486905 0.464546510033716 1 +-0.108004377630347 -0.00542090189520716 0.488376891379299 1 +-0.116684484699457 0.00237686467396869 -0.486214527823066 1 +-0.46542517264273 -0.0904760580175836 0.160107971119482 1 +-0.486223473212064 0.00776714872203599 0.116684877553361 1 +0.459218606845428 -0.105776813021726 0.167200554545279 1 +0.362319094515356 0.205088199373244 0.264937522986709 1 +0.270347196028724 -0.324616085441805 -0.264783424491515 1 +0.289685485099508 0.265266619439045 0.303613742957912 1 +0.290517539103468 0.305598582099047 -0.265144807222874 1 +-0.297645015937318 -0.296168073049078 0.267504106833808 1 +0.261295633052169 -0.326066965219791 0.271860283790673 1 +0.347608920110507 -0.106594134289887 0.337665344590287 1 +0.310794050986619 -0.0026276825427124 0.388513086212735 1 +-0.248306027407549 0.197095981411885 -0.378706619907737 1 +-0.231081564435435 -0.203325345232794 -0.387354274250985 1 +-0.349887253290318 -0.080219069070689 -0.343844156106187 1 +-0.370038376245885 0.222179782404793 0.2413326485787 1 +-0.335688340263026 -0.114525731646225 0.347024403594952 1 +-0.257723283915544 0.336136996581664 -0.263275808538153 1 +-0.307145142096098 0.264185083284538 0.286829699075243 1 +0.327470957113086 -0.0955899943332473 -0.361137102819281 1 +0.382362690729797 -0.00959900301358246 -0.31839859047801 1 +0.373834618189597 0.228778542288055 -0.230598184156995 1 +0.338634034246505 -0.183879161570872 -0.0664523211580024 0 +0.357454239557296 -0.24942123493807 0.028483571918793 0 +0.110851801292589 -0.171942717626728 0.362153786227972 0 +0.13987097011448 -0.420062046019398 0.123289294033504 0 +0.0588661483068754 -0.428678258675551 0.120197000841927 0 +-0.110523489123478 0.335680164492769 0.00801303400011777 0 +-0.00409589952873424 0.125374326547005 0.0963714767251764 0 +0.19510606901065 -0.0472079298001264 -0.381950141737855 0 +0.107093141257174 0.130445333630781 -0.377738043628761 0 +0.110299456727145 0.180515282193375 -0.243282330304958 0 +0.345921227588565 0.165332439906915 0.106952520736634 0 +-0.0732278884823717 0.295187720656154 0.280450944545056 0 +-0.36778 0.1797 -0.095795 0 +0.127207947190846 -0.205269860594114 0.190919131869309 0 +-0.0976115035988322 0.150042450659668 0.372842337655365 0 +0.274709883777248 -0.326390714745246 0.131210401935163 0 +0.0869051900083921 -0.403081084665633 -0.0234889320898859 0 +0.013050095568747 -0.405304052911718 0.0794213383422873 0 +-0.0319720706386721 -0.420389528943222 -0.0661458899460987 0 +-0.0825537032056072 -0.493011496545425 0.00279727185713319 1 +-0.307354020650179 -0.0176600492399139 0.034197583762963 0 +-0.06374 0.40236 -0.013515 0 +0.285572009754736 0.338156259446627 0.0751618155925672 0 +-0.00015015505322602 0.497579803482559 0.0481362370616721 1 +0.0403755270390797 0.110993535599917 -0.389638760746001 0 +-0.248857132743817 0.0466843565350323 -0.0661102810888888 0 +-0.0314157181304062 -0.1147637779528 -0.348430748641529 0 +-0.250995031017561 0.163818812902172 -0.099636374563679 0 +0.174679845548003 -0.193856932959055 0.126808005191941 0 +0.270866068161963 -0.291461285721066 -0.190551612527023 0 +-0.0543492206044835 0.109157836703715 -0.384993664834597 0 +-0.140281218433651 -0.0921788557657995 -0.064551386823056 0 +-0.232350409805559 -0.0157348024982834 -0.1049280898675 0 +-0.0828932335004215 -0.14596276179718 0.386118573037277 0 +0.338774030225027 -0.0768156421461665 0.194623289154316 0 +-0.387040020392763 -0.120617372072528 -0.102910119587531 0 +0.108829082344816 0.20662498744943 -0.340927463112435 0 +-0.323488479114591 0.23516246987614 -0.117262143837586 0 +0.345293687943438 -0.227360260724652 -0.142628223632074 0 +-0.0579198583255442 -0.233762355434855 -0.292582844201217 0 +0.292078479114591 0.21880746987614 0.111477143837586 0 +-0.118122143837586 0.21581746987614 0.331308479114591 0 +0.117268225054046 -0.235112571442132 0.323412136323926 0 +-0.314123362858617 -0.226297232434677 0.084709265160071 0 +0.113242504680696 -0.385382653648221 -0.0733011921242849 0 +0.0952527818514385 0.377963497552552 -0.112719486929031 0 +0.424544990934751 -0.0625270185843226 -0.108769652477709 0 +0.334397476576425 0.230245802225374 -0.136271688812196 0 +0.0382624941186404 -0.323822213033674 -0.191126850213412 0 +0.310528431873648 -0.207562146378261 0.0699999076400761 0 +0.233194352485464 -0.0736725617650053 0.432676239060829 1 +0.170070210036458 -0.253405403134505 -0.39474924416547 1 +-0.367235505033875 -0.225199613790486 -0.151667166229261 0 +0.131547504680696 -0.354687653648221 0.136416192124285 0 +0.282048126607676 -0.287064274659576 -0.0656061801607691 0 +-0.136416192124285 0.354687653648221 -0.131547504680696 0 +0.126261592259163 0.424848459060613 0.0728052797027514 0 +0.152227690538711 0.366011422771247 -0.189402705281799 0 +0.136240106913814 0.289930013031983 -0.237019884722362 0 +-0.0977078249741257 -0.316781830560433 -0.281400267617073 0 +-0.0279661921242849 -0.354687653648221 0.176357504680696 0 +0.09077 0.40236 -0.013515 0 +-0.162090663871968 -0.356299204896836 0.0724730525461329 0 +-0.148064498619392 -0.312253517779627 -0.0670696404491216 0 +-0.186013705319295 -0.260128990548957 0.382684325590698 1 +-0.423880772276236 0.0781588758379613 0.0250893761428622 0 +-0.322771463064614 0.00404438968629595 0.28684580324883 0 +-0.176357504680696 0.354687653648221 0.0279661921242849 0 +0.190095239499355 0.199349358529339 0.0781776145805674 0 +0.0328133270625253 0.341423165855873 0.146393587157915 0 +-0.0838320494459253 -0.346312231312713 0.0442051908541102 0 +0.178622329629211 0.364150999230629 0.106864456199636 0 +0.0135149999999999 0.40236 0.06374 0 +-0.402775665706711 0.145157110614486 -0.134071024810732 0 +0.363728660616606 -0.0262560828265148 -0.104662710676179 0 +-0.262717258143549 0.155684325674937 0.217819654102221 0 +0.0380220110622183 -0.322028196566435 0.309842510205388 0 +-0.272376599961521 0.32323741885307 0.0599215951602583 0 +-0.126844386262699 -0.44330510793136 0.048371071148299 0 +0.247979559375493 -0.0844542472166736 -0.324207621899061 0 +0.17086014058596 0.182832858144244 0.340490617966479 0 +-0.357095 -0.21412 -0.00197999999999998 0 +0.168725813622692 -0.410983337919397 -0.0201635403671874 0 +0.234326337617119 0.00733180967437874 -0.0266853441401832 0 +0.0413207739834586 -0.167865108696897 -0.0055887310900003 0 +-0.122231790723004 0.372842179474805 -0.0697493632195573 0 +-0.033233092247637 0.39229376299826 -0.157801786120241 0 +-0.110424758218198 -0.0588297009390351 -0.268374351599634 0 +-0.0632745883097193 0.14714200150971 -0.0209563712174539 0 +0.133135596062143 0.361491326824111 0.193928752340348 0 +0.155014855277112 0.228586432613636 -0.108904848938913 0 +0.120763821116189 0.318223898266242 0.252120888664275 0 +0.000784910730321164 0.425341928279741 -0.0183325014476762 0 +0.342724637595282 -0.109222802174585 0.14011820878505 0 +0.00777755115405532 0.366418314325424 -0.0787530367342512 0 +0.130526563370944 -0.0723859942220331 -0.374483731545356 0 +-0.0795734468286962 -0.0822562743058443 0.101443314837773 0 +-0.356140028877507 -0.114037965361443 0.135832445049658 0 +-0.379625546357524 -0.116969422270223 -0.19425446172097 0 +-0.343037984644588 -0.194299904032576 0.159335448944268 0 +-0.0644781751569329 0.367701610824783 0.0962731751569329 0 +0.212195133594011 0.362719129227542 -0.0639226159371081 0 +-0.306435198633865 0.0280396649608106 0.190220239758849 0 +-0.283257700181397 -0.0514905097828321 0.324506560580488 0 +0.157922798031071 0.327948163412055 -0.085466876170174 0 +-0.0707144670225522 -0.237960138022866 -0.0647282578244976 0 +0.387445664528753 -0.152766897038384 0.111451488124257 0 +0.360715271502047 0.119854136248196 -0.0346219365074663 0 +0.247135 -0.08309 0.051955 0 +-0.106166147415421 -0.196537120716356 -0.355019358433283 0 +-0.0591623046878008 -0.42616506212161 0.0188681453726316 0 +-0.206627045843104 -0.140276308306632 -0.43073518220769 1 +-0.156105080238672 -0.261080211764624 0.076520499512405 0 +-0.0478788273008457 0.322052560632532 -0.197473458580288 0 +0.0309455960621425 0.337076326824111 0.064708752340348 0 +-0.142503232426207 0.376448785684864 0.138633241464338 0 +0.05682 0.2612725 0.0574162499999999 0 +0.0363134450880432 -0.136080310231509 0.378551961322086 0 +-0.167756293217336 -0.314571165150093 0.0071552278710636 0 +-0.103398770413067 0.094955468518267 -0.250387499939535 0 +0.095915 0.046095 0.25565 0 +-0.0744247431714421 0.393938305142716 -0.202727160150602 0 +0.19257 -0.11426 0.31658 0 +0.409806498774999 0.105877583120698 -0.104489159079534 0 +0.33413148501762 0.103740808353476 0.128780128586439 0 +-0.363136967258406 -0.0390798666638441 -0.235050495956103 0 +-0.345109742570398 0.217461266587837 -0.187146548013496 0 +-0.129688096062142 -0.366353826824111 0.203883752340348 0 +-0.05222 -0.08284 -0.21437 0 +-0.109021381249524 -0.0858839115625796 0.287752666850339 0 +0.392160561151576 -0.0340574207937844 0.199929554289839 0 +-0.0150599768607114 -0.088799186388707 -0.0236229202707767 0 +0.0509132596284487 0.398518213356886 -0.168703458006066 0 +-0.182339348589777 -0.129343221984077 0.277555761769141 0 +-0.0431423566948219 0.270841593772964 -0.285376453638052 0 +-0.413783222419451 0.084962699986226 0.124900320431318 0 +0.0494052702818529 -0.318379995170244 -0.270753875436365 0 +0.00263559606214248 0.242506326824111 0.235558752340348 0 +0.338211642597909 0.204154954957643 0.17875269634737 0 +0.10690361838335 -0.147521450588323 0.298264583080872 0 +-0.021751745611192 0.231021723547578 -0.0266416297600415 0 +-0.223892964850562 0.333406268510234 -0.0504899746846349 0 +-0.180675132893309 0.0371875870722979 0.375442191233103 0 +-0.178027918219831 0.255662776745906 -0.389569491422149 1 -0.351221068161963 0.166668785721066 0.186524112527023 0 -0.0706901149905012 -0.0647283370590732 -0.346174161692225 0 -0.139661195068771 -0.042968918737172 -0.478509925435665 3 --0.317684039913589 0.0103721825976595 0.334969274036754 0 --0.316123340591528 0.127664777208578 0.267076104789956 0 -0.187421977578056 -0.085984337288896 -0.369677704951121 0 -0.252802742219667 0.22881669506096 -0.235367539069393 0 --0.00806787968126255 -0.046740161080169 0.195423202155872 0 -0.304483984854866 -0.288612210514061 -0.128179292839092 0 --0.05185625 0.08328125 0.0211637499999999 0 -0.0891690618800292 0.0414350062084399 0.00908216723839306 0 --0.03 0.010335 0.0360075 0 --0.0749181924631034 -0.0674045277450932 0.316130847783679 0 --0.075273175858024 0.101020735019074 0.117654617659172 0 --0.108391518941512 -0.342324870412856 -0.00757455370083671 0 --0.0753333395965792 -0.178297862224612 -0.21159846221522 0 -0.264064946357419 0.326871614307215 -0.0854731746874116 0 --0.0642946411197468 0.488663284525763 0.0824644177202206 3 -0.136794280710972 -0.294568988333751 -0.0360640480310712 0 --0.0128758334744393 0.194154918486258 0.460831090136546 3 -0.137156927318509 -0.173808118325139 0.404697321552696 0 --0.0215724464076573 0.221382835443225 -0.181175870413171 0 -0.00823329050185539 0.174490028338842 0.229326435783115 0 -0.110242851087954 0.418113797610611 0.250530169195703 3 -0.100396192124285 -0.306572653648221 -0.218787504680696 0 --0.262603460088727 -0.278783642185645 0.186086663623271 0 -0.183195721719071 -0.222221206519708 0.220691076773983 0 -0.0324021488930074 -0.413144623700166 -0.105060078458373 0 -0.179330262515693 0.229131993227515 -0.218204359714915 0 --0.0422295385568674 -0.0981263301654233 0.343321614797303 0 --0.00423566759944993 -0.326207134671809 -0.0497085328535 0 -0.279080750409014 0.270411076329555 0.0746896013667686 0 -0.239535321169622 -0.317627425103234 0.30121984426207 3 --0.239429388336955 0.112534932905881 -0.238993913592653 0 --0.41819377901575 -0.0288979283127299 0.0628093419442871 0 -0.233867057579322 -0.385809090552931 -0.0549593380457268 0 --0.0299613613017815 -0.0850229775493728 -0.310573590302533 0 -0.12396492115188 -0.111734232198242 0.421612475400981 0 -0.217575984185972 -0.0883402450786361 0.276977370929364 0 --0.0371528889557841 0.177887533317323 -0.079569314861512 0 --0.134838305121677 0.0568084831662303 0.478637994888616 3 -0.0238871010994157 -0.225237257670295 0.446305360303425 3 --0.255715915482768 0.342805688810609 -0.152705761299894 0 -0.05710262562891 -0.20700339461435 -0.390098804728256 0 -0.278336671520028 0.14905560993807 0.0908445068636025 0 -0.147435623891706 0.106206691648235 -0.0258144670147806 0 --0.00942716081015388 -0.112983275607114 -0.232394195974553 0 --0.177952414192877 0.151193083610547 -0.142641872280314 0 --0.0556098815831377 0.217336598227504 -0.380571739710508 0 -0.0272460454266283 0.143501009835526 0.3327731442872 0 --0.0748720879388243 -0.132216292702725 0.148844407461065 0 --0.28758151504184 -0.0413080543543766 0.317812086673305 0 -0.187144805375695 -0.338845791013432 -0.192087582159277 0 -0.0860359548878841 0.225786110117848 -0.0760460751056843 0 --0.226231739557296 -0.0684787349380699 -0.194628571918793 0 --0.010184227472455 -0.203144025816354 0.0505134563622335 0 --0.393559418035665 0.11721734727488 -0.123818501982476 0 --0.257818159577035 0.0597442511316382 -0.338395457682843 0 -0.117439988540474 0.36152924830894 0.322421832375101 3 --0.24205788831918 -0.0464239870372705 0.383484984007041 0 --0.00232625000000003 0.352994349765087 0.103648463622394 0 -0.232712149341086 0.116565149283002 -0.344320842881979 0 --0.0273958479803498 -0.0910087808251077 0.49138662335167 3 -0.11634006645392 -0.104965226006672 0.0901583566368619 0 --0.119368797062504 -0.239024975183892 0.337701152044736 0 -0.136095247161304 0.0504223934689919 -0.479001810207676 3 --0.23291971727113 -0.342856468649342 0.279243966981278 3 -0.204664988287291 0.291441021910815 -0.220487833562948 0 -0.0565015510597905 0.42718542383696 0.0198047280502918 0 -0.282595307947813 0.194080748919601 -0.164162477422631 0 --0.00716492071090591 0.0863479015481042 0.113917016917822 0 -0.149495 -0.1166225 -0.1317775 0 -0.137790725629949 0.0955224088026759 0.306104422129673 0 -0.0304963364616695 0.255017703789075 0.429606086087506 3 -0.312907562224458 -0.343878690585497 0.181876050030399 3 --0.00857583461379946 0.381392036162131 -0.252720938361598 0 --0.206416178739379 -0.0688816815279921 0.10354315339878 0 --0.132844794032116 0.3611423686097 -0.200520462133114 0 --0.0384691674008013 0.148815585751373 0.117318341924176 0 -0.131066180656762 -0.307396820589776 0.256568079523591 0 -0.248529502816402 0.0314581305861709 -0.232399724946958 0 -0.194134263060138 -0.00567320566728918 -0.108478653000057 0 --0.144860830736244 -0.204355502877068 -0.161626829660018 0 -0.073093035990373 0.0280426047291543 -0.494370184372797 3 --0.271149809081596 0.296747899843392 -0.0228775 0 -0.166356623268343 -0.304498080531377 0.079425751247612 0 -0.00643452761890517 -0.447052888478758 -0.0775193362625437 0 --0.00819161827054615 -0.390782071965015 0.310246159458702 3 --0.0474622914936584 -0.141411235709375 -0.273620110463801 0 -0.0946705509859642 0.202092345728551 -0.268219592711103 0 -0.232237664259671 0.338500160684025 -0.28502470285497 3 -0.170925802882873 0.0596150275620113 0.230473673175885 0 --0.248309610940678 -0.0189391537601001 -0.123282165269164 0 -0.352965219755298 -0.127161637742684 0.227535537631566 0 -0.10386660529419 0.0619057307406041 0.230462161444199 0 --0.131003070309879 -0.47917926871757 0.0547709710284681 3 --0.190181612385346 -0.456881803408454 -0.068076778491829 3 --0.012743805997862 -0.212660538890383 -0.172680445134513 0 -0.00216848482681709 -0.0868661420487712 -0.305682129156247 0 -0.07698375 0.0872075 -0.10199875 0 -0.0387027989340571 -0.417030463249908 0.110603871375988 0 -0.0125868172068613 0.214556040303073 -0.451766114771655 3 -0.00254419098325231 0.0439475125962567 0.436635928721791 0 --0.13265177107057 0.377221212534246 0.229739402309457 0 -0.118706361214225 0.383056223798096 -0.151356758716224 0 --0.00110569873177768 -0.0630758123863979 -0.0839595862935167 0 -0.0286321536192722 0.0941135283660028 -0.428470641316574 0 --0.0472295521962626 -0.121612575543646 0.255132409398821 0 -0.31184994712054 -0.0568377754263646 -0.322972169123294 0 --0.309696574657395 -0.254240346076103 -0.130618320883663 0 --0.243710861721638 -0.245260414451504 -0.165222741318559 0 --0.241900209536891 -0.103263794652082 -0.290922035541395 0 --0.0181800958198104 0.499603339240477 0.00318438661173603 3 --0.0143025702159801 0.413237668667703 0.156881327611501 0 --0.0109060569580633 -0.431293661078146 -0.254807144855159 3 --0.225780432825688 0.279455365165452 0.235725783021239 0 --0.13457165090997 0.181239576612762 0.23986909988935 0 --0.190187568111994 -0.182309493092935 -0.325911521818035 0 -0.346102125888864 0.0135989231520176 0.0738334630181484 0 -0.0336655358739695 -0.248563361990534 -0.250321333586303 0 -0.00522759883963142 -0.0843512691388524 -0.386475243016935 0 --0.139913060070957 -0.0511848362634872 0.477666951088092 3 -0.0277137655575702 0.415599536915958 0.163266156292848 0 --0.170378925587524 -0.0346584120810254 -0.404895247938248 0 -0.0192014334458318 -0.282104277364899 0.41264243443495 3 --0.00626357923554127 0.43564272764912 -0.0528689378345599 0 --0.0983255960621425 0.279018826824111 -0.156668752340348 0 --0.0290497103923913 -0.261622609867253 0.331849881547207 0 -0.219353604178454 0.0444020524016887 -0.039323919373193 0 -0.0910788778990843 0.120362558032062 -0.43041970787486 0 -0.118378754665998 -0.0558277472906366 -0.427387293433344 0 -0.0486408465881851 -0.304491208715015 0.0595411353801916 0 -0.00749929930735493 -0.321334656522329 0.382292396247504 3 --0.299515820325991 -0.230755068686562 0.241700312829848 0 --0.125837009330332 -0.0683005132286473 0.0845137984521029 0 -0.0238458464210666 0.305121218579764 0.0833635327692254 0 --0.206792242055111 0.338565359290692 -0.192142453165066 0 --0.0933709029012078 -0.420525739656059 0.0294580370495289 0 -0.184663373734898 -0.348466780558574 -0.0642392833199908 0 --0.305043515826423 0.13708158448509 -0.36375006020592 3 --0.280853740820218 -0.198907498914552 -0.249937649871834 0 --0.065590649827345 -0.442084402364823 -0.054052897197222 0 --0.359452042931932 -0.177972695431929 0.143471774717813 0 -0.00519117062856222 0.362551507824404 -0.0649068649146709 0 --0.0118623115679165 0.307670344341318 -0.127483221219474 0 -0.0357504697807317 0.377403792066769 0.0554920721333692 0 -0.0125151936187997 0.0550237443191592 -0.497141416623585 3 --0.222130475732636 -0.206285242580565 0.39222159471967 3 -0.18141228138274 0.399403695347364 -0.0719870152300624 0 -0.0295611391928376 -0.253499402459428 0.360046107309766 0 --0.20269623508329 0.167999740096331 0.137243042291569 0 --0.232393279965517 0.0727145241993613 -0.160144070805818 0 --0.00368717577135425 -0.193294553523957 -0.409416485193752 0 -0.163783857202253 0.239313290233089 -0.406046293435245 3 -0.388367200388968 -0.184474271875731 0.032242963940964 0 -0.10639399353763 0.369720247362785 -0.317064133802192 3 -0.262627179805697 0.171815538988572 -0.292068423180324 0 --0.0249683432273876 0.254850365880662 0.053919498502271 0 --0.350213863023976 0.0941030149965997 0.133208190825801 0 --0.0841858029541623 -0.0978683302721133 -0.267382747676753 0 -0.0996636079473834 -0.25674230741715 0.221889936973212 0 --0.0711202380754518 0.386072663042331 0.205080558506596 0 --0.00281638671919748 0.190018311021798 0.299040471355118 0 -0.413960071586243 0.0110375312219627 -0.0208888931555994 0 --0.207873932793183 -0.260226941562929 0.144507370379075 0 -0.310786301427191 -0.0880053257834976 -0.256728533118793 0 --0.148236290589007 -0.351984408174481 -0.320795720570546 3 --0.0284018079609167 0.433229637310111 -0.106608396606643 0 -0.0165205512946024 -0.0228146929509803 -0.49943353994505 3 -0.0513404997614285 0.0787418220286691 0.0247929043965741 0 -0.0686031728943345 -0.21839601028926 0.250123880858937 0 --0.095028793945422 -0.405526059467462 0.15452333196468 0 -0.0155552297849765 0.437831983944017 -0.243359828727094 3 -0.176077969511944 0.166369718569694 0.0240658011471996 0 --0.214413976755297 -0.202297045810899 0.0718345048442585 0 --0.245775846273121 0.0419049278013219 -0.0495595070097843 0 --0.171867796306632 0.404932345090299 -0.0841531558179943 0 --0.187383593340475 -0.0473655725824537 0.39087893521275 0 --0.104272548217403 -0.397621078953735 -0.28378608622229 3 -0.203579941421842 -0.158548839169952 -0.372521445535943 0 -0.232559012297013 -0.0302095430930272 -0.440119177463568 3 -0.047728661011865 0.409012537339948 0.171061298326306 0 -0.0336042163866519 0.317111094987953 0.384131378804434 3 --0.0897767782478994 -0.220598331996894 -0.29403664543279 0 -0.0647014642601101 0.280634989711037 0.341014282335003 0 -0.157385816083379 0.174338945147615 0.3597083533393 0 -0.118164076402655 -0.265180791153355 -0.406559957089292 3 -0.076249375 -0.125531875 -0.0724137499999999 0 --0.0146348502375024 0.387252789263743 0.31404082921004 3 --0.225434056838725 -0.367040039076953 -0.0701336762161642 0 --0.230578050652703 -0.341242688062225 -0.282743280777387 3 --0.239325252007714 0.078391974085515 0.165755387161461 0 -0.0534802028187856 0.0975519147029178 -0.372862806998235 0 -0.0363124691614127 -0.0161815396915226 0.498770768242264 3 --0.114833320674637 0.0933989748291315 0.394891311831481 0 -0.00183610890756047 0.108011117871217 -0.408265982631387 0 --0.282125369188815 -0.176014160807989 0.208194444124184 0 -0.336760730225011 -0.209708693491897 0.191820693639648 0 -0.155106166613742 -0.282438585270493 -0.247164885308985 0 --0.1250025 -0.07235375 0.265655 0 --0.0422895912028008 0.292953091658684 -0.328241576061705 0 --0.0467059595039673 -0.276500150171924 0.263656583784714 0 --0.215193489954988 -0.244340274903557 0.228640245651046 0 -0.149769710145865 0.000303907354414545 0.166604639884947 0 --0.125089199754281 -0.126413866021641 -0.34563429626664 0 --0.0222413696988366 -0.282067863021932 0.0407997806989255 0 --0.106195243154622 0.465251678759708 0.146794547946742 3 -0.194366397213323 -0.00279130182327048 0.0651056666600386 0 --0.0761430756173265 -0.075853195452627 -0.489539938812193 3 --0.34570461941885 -0.250146244151534 -0.252201606101421 3 -0.0140814434539042 -0.280599959718942 0.020277018674923 0 -0.257070487383212 0.102523323263969 0.339249676069082 0 --0.206239123583342 0.27455474077471 -0.00566711299223216 0 --0.180721365408245 -0.321190539438139 0.196390053481082 0 --0.12158625 0.14653625 -0.060405 0 --0.0930910155363786 0.197147721957857 -0.115340049234321 0 -0.0693325568501696 0.27771100971351 -0.315469328309571 0 -0.00832332916589784 -0.136421379154682 0.204897864163136 0 --0.109548428380913 -0.153823522775642 -0.0651181374282427 0 -0.0686704469155757 0.252566515398073 0.141120742077435 0 -0.230794136346061 -0.339207729937256 -0.117760219347669 0 --0.238809135441345 0.15311709202247 -0.0626451716955145 0 -0.00386845175174511 -0.021276686098799 0.422966598608079 0 --0.12706185878638 -0.482943152692347 -0.0220172159189335 3 --0.0751666652304704 0.110749917521833 0.394143302321747 0 --0.0036601672199057 -0.495349031132011 -0.0670666535981835 3 --0.0101072897117816 -0.322665188049643 0.262992099110518 0 --0.0653224038255882 0.183757105073493 0.407089688903077 0 -0.0104345622350112 0.26048800542777 0.342906695240663 0 --0.133855138055566 0.234988036645143 0.304838259020247 0 --0.0575496335494173 0.0267634262656923 -0.191266855018834 0 --0.0396320623322952 -0.0291393114248197 0.439095254881108 0 --0.040706959902601 -0.346013993939161 -0.257239407116454 0 -0.126730367898597 0.202894460043054 -0.440305012636667 3 -0.115370897014199 0.0553635505130284 0.4446151243137 0 --0.16504292313656 0.027932463900661 0.0042077464951078 0 --0.0301525 0.20652375 0.17252 0 --0.231212200884302 -0.130898739615472 0.0709133180886904 0 -0.113888184143703 0.343687750754736 0.208298209196225 0 --0.0760806048679732 0.0709596130800542 -0.490187953967364 3 --0.08835848941763 0.315408705645366 0.282272428375228 0 --0.00726496800490029 -0.267238882755728 -0.360106417629311 0 -0.00597724365264241 0.276307857331307 -0.299180398059377 0 --0.0681115362850906 -0.487855246463991 0.0841522757475919 3 --0.0409171063658282 0.0512683357519541 0.174584509044899 0 --0.206725158205171 0.0262322061295366 -0.388073924153693 0 --0.149076020716158 -0.239582345462787 -0.239947893509263 0 --0.0848753952028249 0.492303165285803 0.0105734512571451 3 --0.11698652165413 -0.0106415722113314 -0.425435570585224 0 -0.252898884565214 -0.104683069840759 0.180323930584193 0 -0.0226667268852099 0.268685635379603 -0.275746072195599 0 -0.0369489460462388 0.338378047405129 -0.285350289803375 0 --0.0611211982269338 0.492842203500844 -0.0557408620502704 3 -0.0424003908694014 -0.368471213637542 0.259004770446583 0 -0.0153431089726823 0.316792153231968 0.178944801725547 0 -0.152169759758946 0.289740682389631 -0.17451194187951 0 --0.0292864032947213 -0.380770419294421 0.0183660693883634 0 --0.101250661036128 -0.443847891542751 -0.205340546517963 3 -0.00392290054523947 0.26180969603881 -0.211696878508787 0 -0.0994422221275536 -0.172966720291213 0.192603350230062 0 --0.154796595042217 -0.248280690667934 0.101404400754826 0 -0.0421321411769471 -0.171261461656467 -0.0133368868297818 0 --0.0365287397792376 0.1086525 0.399434727850927 0 --0.0304011211771836 -0.285185003746621 -0.0373501795022412 0 --0.0412813167604353 0.0263826196106819 0.243049716563535 0 -0.204736077458906 -0.334214693996616 0.0121678902729765 0 -0.267988814703366 0.2995862915988 -0.176545571388273 0 -0.050027772147631 0.380709457476897 -0.143575996846355 0 -0.1143025 -0.0340875 -0.00307000000000002 0 --0.0959079690425435 0.156584540853014 0.0906741370077678 0 --0.000150035628926626 0.292634124078205 0.235998834438663 0 --0.208639347690916 -0.194161857101593 0.169942946999667 0 -0.135440380376601 -0.0494786382636759 -0.0815037381390831 0 -0.196041893461154 -0.157111594376813 -0.313130393273147 0 -0.00845825939842249 0.227820242877332 0.444935091058773 3 -0.0718224999999999 0.11732125 -0.31045875 0 -0.0933812630546833 -0.272349519383352 -0.119246176052016 0 -0.000939840424026506 -0.402447540000031 0.148963215808597 0 --0.0241561254701791 0.0519312589370868 0.43659951390369 0 --0.132028803495845 0.127019985244718 -0.395600093802695 0 --0.071761589863609 -0.0847056264827144 0.488753913665262 3 -0.145311173639525 -0.193511533877662 -0.18567541971362 0 --0.0700555399121412 0.0220716081539101 -0.0775220347780542 0 --0.0180173251854555 -0.0957239641769668 0.387948671680169 0 --0.240709294068773 -0.10590400642635 0.348841526898141 0 -0.0816991318580056 0.29306488850828 -0.241584736507543 0 -0.10207125 0.04778875 -0.057335 0 --0.262769047843865 -0.00564897950033422 0.100833182728229 0 --0.345200320362477 0.0668126991987122 0.276566508294924 0 -0.0937738733317502 0.0199028813234878 -0.177563193615371 0 -0.328112873742206 0.181942788337667 0.132832266053914 0 --0.281244157544687 -0.27091759435751 -0.225495842038726 0 -0.107462675043524 0.0903940260671933 -0.137252599229815 0 --0.190908075825953 -0.458319571881466 0.0567893488679977 3 --0.131721791333293 0.187277566829952 -0.298911260387711 0 -0.116315782073194 -0.0832528565024331 -0.338992557144804 0 -0.262528971915362 -0.256762050304031 -0.333168241000694 3 -0.0531380178320986 0.155730934207257 -0.424494245016687 0 -0.0327154552857706 -0.0160084295324139 -0.172080415214146 0 --0.227720805936247 0.325828478225099 -0.101822514361607 0 --0.0255870391625674 -0.0246438960090594 -0.141650705766265 0 -0.0134485913043381 0.102928153033031 0.445125015200239 0 -0.392605502140031 0.163019922098661 0.112893151168981 0 --0.03730970418084 0.176138571782181 0.467093972458333 3 --0.339204258960912 -0.131144967655966 0.228127832835102 0 --0.00399964389075147 -0.0954314344768644 -0.49083625052005 3 --0.0770569675199708 -0.201561363445794 -0.0133041971330738 0 -0.111810025407241 -0.226138190763426 0.117349299995107 0 -0.165199272532836 0.276254160228694 0.215195129633619 0 --0.0745527588063056 -0.136410484645807 0.393990052864142 0 --0.377932764545345 -0.0983061336367507 -0.207688096599655 0 -0.00013896822497006 0.250609463699978 -0.0157052367452472 0 -0.0626401516117563 0.368090215379099 0.165486507289767 0 -0.0843302451482301 0.0684951960493205 -0.412550016225322 0 -0.00515861432790254 -0.257905069114972 -0.315349662995084 0 -0.187570832101518 0.151120475011101 0.187613143609126 0 --0.12823912400477 0.352774470184835 0.327833670469115 3 --0.141192606943553 -0.13012324290269 -0.462798001285878 3 -0.207840943407096 -0.169078106893613 0.140413042373255 0 -0.0975984291587511 0.0400491685295365 -0.340813468076854 0 --0.240766018697745 0.177861472758617 -0.203961505266791 0 -0.00300378826375147 0.140701157661104 -0.158205396151524 0 -0.108793000484981 -0.465966998279811 -0.14232544662442 3 --0.157091504889631 -0.101612011743118 -0.181451078411508 0 --0.0432375222972682 0.233544589242044 -0.440563286098533 3 -0.029278996478025 0.0665074084028068 0.102499500754281 0 --0.210207454563249 0.12528332087737 -0.363306967282189 0 -0.05739274991564 -0.131932032780389 -0.280403295150395 0 --0.17788809690749 0.05973875 -0.239932695898331 0 -0.0372487385952016 -0.0961516735181225 -0.0679346731163923 0 --0.00439127932628169 -0.446081851853434 0.0743969507057349 0 --0.0926952626733576 0.274647814279155 0.104756423282907 0 --0.113367961398044 0.146108310753896 -0.24616592319293 0 --0.0801803209846574 0.355030653319449 -0.339969515257995 3 --0.291770356087985 0.271429585067622 0.0719108237874484 0 -0.0597642411228818 -0.388016841425931 -0.215660695689711 0 --0.050937348807223 -0.416852545085035 0.271643965618565 3 --0.162216772899589 -0.15060209995237 -0.269949055977078 0 --0.0651437460319505 -0.380690189267173 -0.136928279628081 0 --0.160453971473163 0.0717216945218355 0.149666171754515 0 -0.140629418885428 0.183927311371939 0.270357146959634 0 --0.0248409983390686 -0.257096691343909 0.154380697588937 0 -0.0128455962274008 -0.0340695638472525 -0.451544168744237 0 --0.0803468393609049 -0.297342021322497 0.289938144687177 0 -0.0691647485682565 0.341246486907726 -0.189250721335401 0 -0.17967753895218 0.198046443588119 -0.0542630820590823 0 --0.308480990904665 0.341249769436147 0.19457707151825 3 --0.135340691716041 -0.218905145603769 0.429426436705392 3 --0.0759199316083098 0.0320295126469756 0.304156319193474 0 --0.0819503847735671 0.0238512974721254 0.221207238327269 0 -0.0233561055545305 -0.110074755539576 0.125916318884181 0 --0.0875304078566853 0.222655704243665 0.302838493293925 0 -0.0892717828901457 0.0685711506052731 -0.232651252451223 0 -0.149521417893931 0.298805446831589 0.138181026023126 0 --0.104294175877649 -0.0648475854054493 0.146918814922129 0 -0.186150709491709 -0.405767348304198 0.223518046612236 3 --0.180175 -0.0407475 -0.2520975 0 -0.351711567870348 0.1731720296257 -0.164187276374378 0 -0.00353673727500148 -0.239484803631127 0.185329455151583 0 -0.017529007150473 0.124366957061306 0.158931300690932 0 -0.110648337401786 -0.0142622558347753 -0.389088589427406 0 --0.0418880223991448 -0.187139465556153 0.0669338219461949 0 --0.0846042263694774 -0.272796536288364 -0.0670407054338822 0 -0.1188650557742 -0.466967261316815 0.1308449702126 3 -0.15063705494291 -0.407305037170115 0.101305293867184 0 --0.00550977777272266 0.241017186828103 -0.0975048763929171 0 --0.0878471131909355 -0.189327467698615 -0.400339761071097 0 -0.0680666989887181 -0.0956373500610318 -0.184155792324881 0 -0.0342195194624653 -0.235597333114656 -0.336392659636194 0 --0.305022943607838 -0.0671461616496259 -0.178818652240898 0 --0.176906183240381 -0.23963031856071 0.400291951084523 3 -0.180547352314427 0.121659050254609 0.376196189022689 0 -0.0268670266657187 0.434270337517885 0.0732838418033129 0 --0.163934870491172 0.19882277084635 -0.0824817997949489 0 -0.192565726819026 0.256008296886482 -0.028376178347411 0 --0.00218315579109918 -0.344174037633673 -0.360940583905258 3 --0.0591002309364363 0.399402434453195 -0.293733738164601 3 -0.254244256909383 -0.177612223106965 -0.00780092050891279 0 -0.100315415660145 -0.377702554096541 -0.229612867035351 0 --0.10177762079027 0.0774169501187609 -0.330765408799972 0 --0.184571245571253 -0.391789335989028 -0.249149175981053 3 -0.016794805522108 0.180592516658661 -0.038455907430756 0 --0.408162364515947 -0.0498091566345246 -0.06954561359183 0 -0.00389490783145419 0.0689217543890686 -0.261420459960745 0 -0.123388636734581 0.101521670233745 -0.230140666418706 0 --0.0926110201677154 0.369346863004733 0.120131520608259 0 -0.22965124497243 -0.148606398970435 -0.203461462857823 0 -0.0897748812611039 0.136964191999917 -0.0163490645455195 0 -0.203134124630944 -0.11952248001154 0.357294649475431 0 -0.176632308046008 0.00623619578980472 -0.197158699148072 0 --0.265236817966171 -0.179838647987065 -0.109445677366398 0 --0.0721621358460212 -0.0102961398120527 0.49519350417906 3 -0.117033357755553 0.0196123382810425 -0.444883945410928 0 -0.01578974553784 -0.24402989655142 -0.178061844846956 0 -0.243769515293607 0.154790794598344 -0.100017633455127 0 -0.34049715500529 0.330848053322015 0.153732803806656 3 --0.0154323212693854 0.12949567365249 0.206255711319721 0 -0.0715322813316177 -0.375646004046887 0.123440425404555 0 -0.0920275824857885 -0.122042066178648 0.0143708913698974 0 --0.121718302150469 -0.0116144976991749 -0.170767419567286 0 -0.144215014897473 -0.0506025172275781 0.380740325267159 0 --0.0567490256199179 0.282521779103174 -0.113210266353725 0 --0.0242508463139208 0.298003109338138 0.101641601611801 0 --0.495557590415307 0.0604827907110599 0.0272703127857108 3 --0.0714677299810025 0.0584222247060489 0.44245582338445 0 -0.0529311781807418 0.0278718862738657 0.405741785388768 0 --0.0125396855735001 0.310414196840961 -0.335408021746052 0 -0.170314696707025 -0.0143759315539146 -0.0216182808342525 0 --0.240790762297743 0.191691914431439 -0.294517218728877 0 --0.279705357339137 -0.0223819514000501 -0.333855362782954 0 --0.204606994203953 0.208112754612329 0.333163812597817 0 --0.0824476545759566 0.36478971129931 0.329222664833765 3 --0.032650986951607 0.222110834460811 -0.298622712544728 0 -0.114442026798742 -0.211418467850538 -0.130398268671754 0 --0.0491876393957648 -0.42066564100489 -0.119255321489017 0 --0.0205238059943932 0.0645084256060109 0.357324636899038 0 --0.102948125 0.080248125 -0.00121500000000002 0 --0.0678478681445533 0.315583578031984 0.380268690846098 3 -0.220562158269236 0.366813793130031 -0.0386220145007573 0 --0.0485211211771837 -0.252783753746621 0.00709982049775881 0 -0.00144265338337646 -0.175375422355417 0.132223343054665 0 -0.0500411783474111 -0.347588296886482 -0.0879757268190258 0 --0.121826594954075 -0.0493696026104413 -0.0880937275099071 0 --0.129484859822967 -0.312790677506623 0.258832613984677 0 -0.168810309825631 0.357615694117965 0.203778697868923 0 -0.315625948129642 -0.30779080012537 -0.061320813174273 0 -0.0628540088567811 0.183635551034872 0.236784874483804 0 --0.323688355302784 -0.202125410635652 -0.18944954343389 0 -0.0993758463277535 -0.130118529166185 0.474120930319948 3 --0.0340492390151104 0.218853183392553 -0.0122220391525209 0 --0.363131875308319 -0.163490803062168 -0.03225760366506 0 -0.027280377652785 -0.0296858743034934 -0.0854554787990113 0 -0.00455832101224396 -0.120842543549817 0.320047778149298 0 -0.132065546533788 0.30832116863104 0.28616403061579 0 --0.0135058558694395 0.0741671565719443 0.0266595330525355 0 --0.00326717066185889 -0.313551845967116 -0.148229623728305 0 -0.11959470321653 0.167513517793797 -0.0953172284641935 0 -0.000464381459823304 -0.23347363655056 -0.0300506171910234 0 -0.101033617451459 0.424376033491392 -0.244671566314373 3 --0.133938821156269 -0.0154618745661033 0.202321246220402 0 -0.00513769741723313 -0.0744186427025732 -0.172620122982554 0 --0.0679908573727655 0.246953225828882 -0.0378027870447194 0 -0.04809791958259 0.273416803042709 -0.233999761518506 0 -0.0307053101512829 -0.12961279208423 -0.145093954580708 0 --0.138433138546096 0.100862495469162 0.318983922805366 0 --0.0666027584528953 -0.0577460845545864 0.0472453989602616 0 -0.387985766689966 -0.122503090041063 -0.177078815303672 0 -0.0157007357986062 -0.312839794632236 -0.222916592512625 0 -0.057004348679031 -0.217125754009346 0.0740859143350415 0 --0.0183783247218515 -0.38714869895179 0.217643275733434 0 -0.0170007417365184 0.43797336907437 -0.0872846300280235 0 -0.00689549714250703 -0.010060351347804 0.102377122503182 0 --0.00805063002825446 -0.360942030839053 0.064991983534497 0 --0.0864258153920578 0.127594255569446 -0.410445327374495 0 -0.00531355852143667 -0.235344066802476 0.392088461522157 0 --0.0329964959917543 0.431573106536605 0.0863434342720869 0 -0.0567044951174527 0.19551424474733 0.099504020775488 0 --0.0837970259580075 0.235788596990151 0.176111913239146 0 -0.0831612568025699 -0.260126202924222 0.342183856547887 0 --0.207104112527023 0.218717535721066 -0.141608568161963 0 --0.168468347696685 0.0343555171973874 -0.33933730849836 0 -0.199336889279002 0.454817961867513 -0.0563417475188533 3 --0.126806445735098 0.0617071008861687 -0.117980357995165 0 -0.220956792387246 0.0796814520892237 -0.276104770011298 0 --0.330003290387454 -0.0324779161554843 -0.0917531580747184 0 --0.00259764947769908 0.0302041764067439 -0.150314193399701 0 -0.0175505853142811 0.298298253912202 -0.114195932457335 0 --0.0757506809471039 -0.0824536522216689 -0.346198946500533 0 --0.1290973029106 -0.361467719178275 0.191787214202969 0 -0.0242023396163394 -0.469013208379731 -0.172774772331495 3 -0.228347408947521 -0.114978640595159 -0.425678191838325 3 --0.230042242251239 0.032755820424086 0.441010386623783 3 -0.138525911871518 -0.186140413024881 0.0611009130340506 0 -0.0546450832349589 0.0890088812261379 -0.241658587434532 0 -0.105779479680369 -0.0636429110836406 0.282649819338876 0 --0.124340684276286 0.190304942920626 -0.393345122801269 0 --0.024548950288324 0.241779288437131 0.253795748299376 0 -0.00536168774406875 0.436065883987686 0.0765381969771428 0 --0.0924764995700305 0.409137397711751 -0.271661693313713 3 --0.293158955982377 -0.187179465340405 -0.0297987171450932 0 -0.309000327776238 0.0879459132333396 -0.146450039441797 0 --0.114857198632465 0.119815631806391 -0.174235623242888 0 --0.0105551056988362 -0.0821422766938988 -0.429771048246153 0 --0.192594600457388 0.195438349399647 -0.330275617469546 0 -0.340592537449609 0.248652054883191 0.259920990656474 3 -0.138181512393184 0.265725729611477 -0.0868616280072162 0 -0.0647311509776486 -0.240203400741616 -0.194146098724535 0 -0.038174179002655 -0.252977270726255 -0.0749910826758988 0 --0.072587295205819 0.473800995018716 -0.141475108775384 3 --0.0925255607962953 -0.194303851159583 0.385159480954837 0 --0.0318045216062275 -0.156763631577133 -0.474411373499261 3 --0.288547264429563 0.13605647598926 -0.12422363726193 0 -0.153953141317763 0.240727337083885 0.315119071209649 0 -0.048424787380193 -0.256236266980111 0.0047384509006535 0 -0.0275093718457295 0.381502676989957 0.235128044730676 0 -0.0581486890901544 -0.294536292842179 -0.148647224905624 0 --0.0271753007132778 -0.168763024423881 -0.413816952347408 0 -0.00778797063386083 0.0400470596909422 0.196017855840447 0 -0.181748231164734 -0.13298517335908 0.232686126657046 0 --0.0326267832941503 0.0321378467527531 0.101692238298944 0 -0.0219199159395462 0.472934808307102 -0.161226667432533 3 --0.0289827967103544 0.089501825481566 -0.217129648564015 0 --0.0100873643130805 0.168527987169279 -0.0624376371258654 0 -0.19839355224619 0.213897552196936 0.260140218582156 0 -0.077205 -0.33508 0.0698725 0 --0.0270372849149628 -0.306138985426395 0.34410557708573 0 -0.0961050978876276 -0.282791135105589 0.0924695576739382 0 -0.261536269379998 -0.00444226627398503 -0.121386506348695 0 -0.109404329499345 0.205454245696115 0.152420674565507 0 -0.0639422445652148 0.220908077010086 -0.18084387919501 0 --0.184752971345645 0.364557414385499 0.286862360658385 3 -0.0120551692301405 -0.0376349746332498 0.498728825738598 3 -0.299317516847534 0.118030391044941 -0.0122725762903482 0 --0.066457690074755 -0.494724108016933 -0.0241555183805314 3 --0.021953353724616 -0.39429289618867 0.144666291338228 0 --0.0604287807808561 -0.0828129307826062 -0.0985646919100351 0 --0.106224112708732 -0.255127966341159 -0.358181426808673 0 --0.124511770843093 0.483548484420614 -0.0229118430131536 3 --0.111090211844412 -0.036318520173067 -0.0144323847974519 0 --0.176200019518896 -0.0571386661243585 -0.0344634303253747 0 --0.0606364461783868 0.418824494634523 0.267001433922115 3 -0.0587394061875883 0.309141639057564 0.192003269522209 0 --0.226621880577132 -0.118857509682202 -0.0345974830190699 0 -0.359018156235385 -0.0600479052540286 0.284545601210616 0 -0.0304798553814003 0.0590137146199571 -0.345621710163938 0 --0.0935538194398504 0.224438429015265 -0.240449209450413 0 -0.349876681024099 0.25409740472618 0.0519247234018592 0 -0.110209278308096 -0.288928113658608 -0.313824896576335 0 --0.18383577558825 0.343639945272266 0.192334195456083 0 --0.0269404792183633 -0.3643929754272 -0.171976569366377 0 -0.08456804655492 -0.3638422614006 -0.329687599956787 3 -0.0151518134194178 0.152281667603436 0.399286004473494 0 -0.0136046262265618 -0.162677414724896 -0.370057008448876 0 --0.00899334648775907 0.277987492029334 0.415537598436765 3 -0.0151263677661013 0.499563646371213 0.0124522991320825 3 -0.000976027246571531 0.0192163751861341 0.0362794796295332 0 -0.0263422497917788 -0.142592829910335 -0.434621843422201 0 -0.0566206955462198 0.192282566064391 0.0201098663156937 0 -0.0539375 0.1781025 -0.07957375 0 -0.0742878664964098 -0.0469678073818172 0.437463121962463 0 --0.105175665412882 -0.0809098002496951 0.373702547785768 0 --0.173101952806136 0.130940781693964 -0.0134981095935166 0 --0.289160414927683 -0.31618402171818 0.133415066011951 0 --0.00927647263943465 0.345266668012439 0.359239294072549 3 -0.203019041534597 -0.101885826825386 -0.0667554489587389 0 -0.0264830801191341 -0.396140072857452 -0.195440225951874 0 --0.15088606321297 -0.128048241915005 -0.0209614577388046 0 --0.0593675732424623 -0.045426335955527 0.12826043429741 0 --0.100017875864686 -0.357847944339151 -0.124896631362484 0 -0.0388597469202532 0.25619470781819 -0.0108769652504546 0 -0.0474042790415559 -0.127522743574315 0.0653223298803579 0 --0.070954774163141 0.365627128421809 0.0187563443060179 0 --0.023242325103978 -0.346335103357209 0.358769553072336 3 -0.191286218113476 0.277729385539125 -0.127584423179156 0 --0.00989546549105064 0.111189226480674 0.48765841571703 3 --0.235939158170657 0.243087786650605 -0.076098997684078 0 -0.0719637336308604 -0.490312303419833 0.0645993464339287 3 -0.0388688442038169 0.142739046415091 0.0643423204076131 0 -0.195341336531168 -0.193081473811472 -0.136678167304816 0 -0.0401623058546994 0.108326639614469 -0.15389647301875 0 -0.151840257991925 -0.130081239124739 -0.369474954073243 0 -0.0520255150821547 -0.423699097437685 -0.261190709911174 3 -0.0970101677176924 -0.439730293002632 -0.216056502396639 3 -0.0689205010868924 -0.31727801150393 -0.378606926522394 3 -0.0998052234577879 0.204778257699037 0.0730116210387177 0 -0.0238633381591592 0.0441277858454059 0.270990601638087 0 -0.0148510112851972 -0.0922182425800558 -0.491534926779323 3 -0.031963006045624 0.089686465335061 0.425265621529965 0 --0.0740334702558579 -0.343111270302654 0.353028814549005 3 --0.0472762374971059 -0.223811472759023 -0.193388518017699 0 --0.10644543823265 -0.368657933410113 0.0970942842621121 0 --0.0360941088250802 -0.111305713196872 0.0240047585113319 0 -0.0724556963018375 0.0396908198365187 0.256319686455024 0 --0.0714328807100765 -0.295918712879861 -0.13886247048428 0 --0.0549891043925251 -0.192335151087293 0.229084818797641 0 --0.0135546163429806 -0.469489565541747 -0.172236179197772 3 -0.22656176644267 0.150544605962768 0.413924799788385 3 --0.17614807766939 -0.258007263968636 -0.112898144133149 0 -0.0666155891737055 -0.312427273443241 -0.0324916134095129 0 -0.28920614641061 0.0564644632026884 -0.0641567232493236 0 --0.137354628161324 -0.331819699579116 -0.207518416340359 0 -0.0263325963866174 0.0715448762884215 -0.209163940652659 0 -0.20233152434459 0.104063136838561 0.248686975217106 0 -0.238132290360381 0.0949705088812041 -0.167780444532561 0 -0.050646875 0.0469587499999999 -0.0439793749999999 0 --0.1171328240052 -0.172817185947646 -0.251601246150553 0 -0.106694930687759 -0.336279623710593 -0.163883822881168 0 --0.0203730006234816 -0.103266008987167 -0.3774020571477 0 -0.0627294648589591 -0.0713811790571584 0.250306716361738 0 --0.197356848160504 -0.0630263903174014 0.239908711453244 0 -0.245516345740145 -0.249478829976425 0.0365078863604679 0 --0.280692196040594 -0.108913228570992 -0.0984702835772859 0 --0.189517769997784 -0.24019355823693 -0.393275522961643 3 --0.278010798556244 -0.151434140104812 0.281341977169975 0 -0.0213207400689343 -0.0734204560647705 0.0109630038561448 0 -0.131193770056922 -0.347020069934623 0.333076614488989 3 -0.0276200301180787 0.0176097339074506 -0.431305370328638 0 --0.0322777801800167 -0.338134274620463 0.278449299022691 0 --0.39914495312562 0.0437993911217949 0.106516216397973 0 --0.00591482813099392 0.0766498106898921 -0.494112977568785 3 -0.00211061390342104 0.0136118038644423 -0.413337531912232 0 --0.0217188028517145 0.356168139137594 -0.138899283132051 0 -0.234926239204116 0.230433508861412 0.131133658804219 0 -0.221299799424003 -0.062497245253118 0.1106101508284 0 -0.0858267914026507 0.356331551206789 0.337207126742029 3 --0.0567804862636611 0.14795775440551 -0.288888690006141 0 -0.0163903454852787 -0.453980711398919 0.0102322452504822 0 --0.0380651388108728 -0.291920850698754 -0.118636027250974 0 -0.236512112026732 0.220648442543544 0.297853859327039 0 -0.40799168765356 0.00785242078885151 -0.143821679739804 0 -0.195390676769389 -0.196041744008658 0.0307536857272455 0 -0.104145287274121 -0.134192105646405 -0.169643019668864 0 -0.0884290733894892 0.154292680102682 -0.184040772911491 0 --0.145308534696621 -0.206324680872146 0.257213806064314 0 --0.112280219847061 -0.158896981756812 0.103949768652662 0 -0.0319128852540197 0.112353841386136 0.233016207992702 0 -0.210082140355486 -0.277991994166876 -0.0412120240155356 0 -0.0161136996295992 0.0946352426692078 0.0112221455528475 0 -0.1086909043514 0.0490966292699387 0.372751123786299 0 -0.0528266130981336 0.342072001932623 0.265094819150522 0 -0.249752973472453 0.0526466466180946 0.426130953034544 3 -0.205241699423627 -0.00814531553430764 -0.300452710013631 0 -0.262365327161688 0.0257086275013968 -0.345249124410227 0 -0.00917793370049225 0.0141301344524217 -0.0449629194518013 0 -0.0303366829359186 -0.10432079652369 0.218024136768118 0 --0.0922527972342643 -0.241274989225981 0.234284985600494 0 -0.107151077518196 0.259584867336054 0.22741467233017 0 --0.0197233222906419 0.0354443384977352 -0.0568573639415663 0 --0.213331198610863 0.120810875456078 0.350968704951035 0 --0.100944880825271 -0.136656778282764 -0.402328323207642 0 -0.199839009742396 0.122119101455171 -0.0474195515911413 0 --0.065253222238946 0.140684383329331 -0.078052328715378 0 --0.0300046446282638 -0.121272648026965 0.165612575076489 0 --0.0273576479958609 -0.0137615068067873 -0.450955601724873 0 --0.245930423626852 0.268464150884538 -0.239172323908686 0 -0.197472225405336 -0.456389121299155 0.0513643896352098 3 -0.0785209180220147 0.346781064057183 -0.348520340569072 3 --0.223929168249419 0.312778248101364 0.0663831466870904 0 --0.0548747083879035 0.302534052942708 -0.183208349106546 0 --0.26412771403623 0.271905211759692 -0.171859366894423 0 --0.052926854044508 -0.250158272946914 -0.0782424312680676 0 --0.194876576287882 0.104957375255824 -0.0905006586988179 0 -0.200094852830795 -0.0837417515753695 -0.154160383534432 0 -0.235460681709277 -0.0439354900104302 0.367793063473532 0 -0.372326803158122 -0.228285277341349 -0.124427978057058 0 -0.248923063294685 -0.0318425402360316 0.428621430229778 3 --0.234658752007818 -0.0237307141540584 0.162466625801522 0 --0.00940300707121766 0.267018242982858 0.317694794049793 0 --0.137642632129933 0.27243041251788 -0.301006571682844 0 -0.0718425614476765 0.483336708451152 0.104658513061607 3 --0.0452143903904281 -0.0362389653913031 -0.0312785959550176 0 -0.0125905010683278 0.139081957723053 0.0894502088849378 0 -0.0116869378288762 -0.386226347981028 -0.229940076005177 0 --0.247405768466985 -0.0360389788926417 -0.0434301474162677 0 --0.0807531773482919 0.0119900602007074 -0.420035281672048 0 --0.260496138834888 0.277028530038349 0.150836865756322 0 -0.115871058942814 0.252541444570532 0.336625677364043 0 --0.0526566341527234 -0.403693505603435 0.19318515041331 0 -0.0109834156152896 -0.234865072008703 -0.379712089539925 0 -0.0492089254728754 0.398907222900051 -0.296555162843062 3 -0.222046720776477 -0.200914763846409 -0.0773853767001199 0 -0.0659568933123619 0.050518150315659 0.0993995372805155 0 -0.00282278589008 -0.0360947728420046 0.354455720209972 0 -0.0524959393263271 -0.291551163985583 0.321137207455963 0 -0.289805617121103 -0.206309889117601 0.255932757533772 0 --0.00553039290591262 -0.143571076528865 -0.0254218611958657 0 -0.245102228899666 0.105107937825494 0.141131210966304 0 --0.136025157119418 -0.184732612898027 -0.44560075666391 3 -0.0030388237943163 -0.100021359738773 0.422923632715014 0 --0.166499091591439 0.350374562051516 0.110792145191439 0 -0.0134351484261991 -0.296262696950847 0.21649232475818 0 --0.18312344235242 0.0248530979254957 -0.0666341901286691 0 --0.148893394920192 -0.000791794552435499 0.111139826929897 0 -0.291398666220695 -0.126472217184553 -0.320817210822265 0 -0.12746705263947 -0.273929084120527 0.0281094084992819 0 -0.0854751536949263 -0.274003012223043 0.0276774779274753 0 --0.159701869889619 -0.00429374999999999 0.281584863925464 0 -0.0314616665859579 0.00689933248101993 -0.258740523957967 0 -0.173555916654022 0.310430117655103 0.268031525285328 0 --0.211294601357547 -0.267980581739756 -0.264936668786629 0 -0.165447646590036 -0.0909838927823017 0.0506986965119507 0 -0.182471040260437 -0.406478930049622 -0.0523621241782065 0 --0.0831247130842078 -0.160750744985744 -0.320965279642759 0 -0.0946520373000821 -0.0103228184277076 0.228739425110121 0 -0.0304034313928069 -0.0309997285690164 0.264950498431997 0 --0.264116059097207 0.0642470091553671 0.299925441429569 0 -0.0677171394726495 0.201979473664501 -0.45379491231541 3 --0.381164709651647 0.21231951430552 0.0659255117721398 0 -0.199735795723017 0.280034941300185 0.0970432471821993 0 --0.0677757161690731 -0.280424460545959 0.40791763333715 3 -0.00631852386282072 -0.329781016435223 -0.290671146499634 0 -0.0526665896658801 -0.303085920117072 -0.216720355343641 0 -0.0503950752253124 0.0974422434475126 0.299177296957197 0 --0.100386628732815 -0.0460989296952219 -0.488282663963964 3 --0.0076613302819285 0.406131490390803 -0.112726159561396 0 -0.122692351684597 -0.285725988444372 0.389416959210161 3 --0.119762598282005 -0.209271786648521 -0.370830444876099 0 -0.0184426538365902 -0.00998288088440119 -0.346638904188937 0 --0.0706510631509341 0.307154998621977 -0.315960113305304 0 -0.340569116468957 0.265578111934899 0.118003393078703 0 -0.0305914100783187 -0.424677001608979 0.0333552810192421 0 -0.199984323866336 0.217399410209586 0.334394285803123 0 -0.136947280614285 -0.240227602885835 0.209951659293261 0 --0.00864734753522095 0.223289295138138 -0.447309137831541 3 -0.198900660291518 0.307409668694412 0.0289427393699971 0 -0.261148018624188 0.168102207756722 0.168070597568753 0 -0.205075295559801 0.35172178347927 0.15597551029726 0 -0.227261105931059 -0.369127741119283 0.0652480075652287 0 -0.402112559145878 0.0893883358223238 0.172571981868428 0 -0.0289590080174896 0.408184724966193 -0.172215660525666 0 -0.180250546840251 -0.4234132485075 -0.192925482113477 3 -0.398222093142405 0.116987570867417 -0.194082950327611 0 -0.0132288936076147 0.378591883500482 0.324081823512886 3 --0.145029318994885 0.148121013777937 0.377079437004091 0 -0.0889332522716787 0.425674314862529 -0.0346282314749446 0 --0.0413350097028116 -0.111769962464821 -0.423729594556115 0 -0.14483937958196 0.168492896414155 -0.40340278215655 0 -0.257326886998793 -0.318989759728537 -0.186686535120918 0 -0.047546935983742 -0.33972551504045 0.134720234463472 0 --0.0894579925031459 0.433114123574328 0.00624994805808365 0 -0.0322759633697699 -0.0172215548140103 0.12728067899396 0 -0.245364743077168 -0.0341303433542235 -0.03445725414014 0 -0.0535235169098864 -0.414124527138366 0.167617167185836 0 --0.0584396861994528 -0.0387367000029659 0.376623144932921 0 --0.0689716802121141 -0.367707391712864 -0.208564713571309 0 --0.397257107705544 -0.0454629191519487 0.140777601235897 0 -0.0403739033308605 -0.229662892922688 0.289945866127903 0 --0.0233682828623629 0.0334118490387458 -0.498696240601971 3 --0.0170247168739812 -0.491006788170373 0.0920212438831507 3 -0.0568210004656424 0.119727338100262 0.389900220472888 0 -0.0960453680401298 0.0145164205494421 0.427844654839672 0 --0.0613704027298015 0.437324591892847 0.0536543123598159 0 -0.00824249665176247 0.127124075310259 -0.483742817388527 3 --0.0243978626193025 0.301894776224426 -0.201514141344829 0 --0.121093664796265 -0.101370668896371 -0.238955745272612 0 -0.170722154218486 0.142544198249231 -0.118812342620682 0 -0.099491555977083 0.407010219344873 0.157494606464069 0 -0.0904233908991482 -0.419389682040621 0.0771730678470605 0 -0.0159997779704456 0.296686693815994 -0.401810226065591 3 --0.136648462489522 0.400266313770675 0.0719041215142542 0 -0.1659625039298 -0.353349380178329 -0.311108774283973 3 -0.146744280710972 -0.370675238333751 0.0141947019689288 0 -0.140537305919989 0.210178927661428 -0.344675027709768 0 --0.132709614804317 -0.135910035404405 0.3996991129657 0 --0.068892924741243 -0.122439567826132 -0.0242287601969196 0 --0.146084420238038 0.129980049005689 -0.46102330982262 3 -0.0313625099773047 -0.158220669223199 -0.473860628425619 3 --0.161117738744769 -0.237190222844881 -0.309895017307118 0 --0.0249279341412834 0.142064826158156 -0.479064835234541 3 -0.0263073696122813 -0.217425613317814 0.0765074405040258 0 --0.00891633902248823 -0.394483064309808 -0.119978783075427 0 -0.0798324055178202 0.260059653564382 -0.370227541934094 0 -0.262575312587334 -0.143132636607887 0.320190284909036 0 --0.032663625596538 -0.0942234482930171 -0.0522523715560108 0 -0.0396817378895296 -0.431986757826878 -0.0433010186369701 0 -0.205069683356534 0.164910537462901 0.107177230032361 0 --0.139093545198844 -0.139869239409443 0.460641543478013 3 -0.0626832020156874 0.0898395184758105 0.443335951969928 0 --0.0337921409293129 0.0885811247949089 -0.0991210250201242 0 --0.168309725413319 -0.0809258818473856 0.0362684111588636 0 --0.016596386317045 -0.188488029101847 0.209410502687901 0 --0.243718588711689 0.0240856724259541 0.363127956499292 0 --0.319969071394208 -0.048884630289738 0.18836781621237 0 -0.0170001581153328 0.360192434919798 -0.246696391915974 0 -0.379725599175461 -0.0597367849237463 -0.153057305004674 0 --0.105452027911568 0.271720066634645 -0.089996129723024 0 -0.227013672155878 0.323907045683911 0.221710101626486 0 -0.146890457620589 -0.0519662407081644 0.112811153908679 0 --0.0829762039420148 0.145211802448302 -0.472826080912638 3 --0.0445508959412213 0.391468259102628 -0.160650823052824 0 -0.000500027238134582 0.0951035588614287 -0.0697551048928796 0 --0.0957341007035648 -0.417179789479819 -0.0793225353704553 0 -0.23532456473954 0.233713748153088 -0.307337479789793 0 --0.0274883318636117 -0.236951930081797 -0.376690228346117 0 --0.0317499771622974 0.28101193216605 -0.0534403215901894 0 -0.134977732703569 -0.324520418994173 -0.288127720218678 0 --0.257464368621737 -0.171876531780901 -0.315317858441583 0 -0.206040102332934 -0.289824386211822 -0.260439706763231 0 --0.0182905557922259 0.15847499835273 -0.405364353387709 0 -0.0619737093790943 0.435949606865442 -0.0736146788256103 0 -0.065398329620476 0.312341075215945 -0.072303666830237 0 -0.000135422439753508 0.498197931285552 -0.0413555504863167 3 -0.063643083779567 0.335857264970244 -0.277469966535372 0 -0.014287728826605 0.0652271499942716 0.365004587199679 0 -0.0449804889201094 -0.412134037392818 -0.159926024653886 0 --0.0808036556610099 0.190520240006171 -0.404386183643273 0 --0.129480306398751 -0.411136386503244 -0.0567299957601798 0 -0.300421713491343 -0.277797473716368 0.150041376094673 0 -0.0521754277184453 -0.158594135177635 0.417317722640235 0 -0.0078165704255494 0.0504760053220041 0.497657989600879 3 -0.0556214177717165 0.00886735877418288 -0.345586336475056 0 -0.028863710408632 -0.0446715642579614 0.426331241749829 0 -0.307715752191906 -0.262295599325126 0.0855613372061459 0 --0.00165134323852673 0.122971288982579 0.41144572653884 0 -0.00771025361669397 0.362951285674817 0.268688977192314 0 +-0.211576294213737 0.187188542560809 -0.194099577532132 0 +-0.399392388968124 0.0767862352200159 0.195524662392258 0 +0.168002950032584 0.360103305631088 0.302086244273107 1 +-0.372023943757541 0.0309269354642103 0.229002833701285 0 +-0.0622027580203626 0.0327882939060374 -0.215754694563998 0 +0.221544673004008 0.130955438775093 -0.264897755147908 0 +0.10047132263745 0.324074275692467 -0.0471836477861141 0 +0.195644618163192 0.360378299686783 0.000696250000000065 0 +-0.030457942913963 0.298388009982631 0.164255681438528 0 +-0.0738566689717832 -0.166412324765537 -0.165746768439011 0 +-0.21573908894847 -0.00350297195140109 -0.293845153515882 0 +0.0944038574426097 0.277828666790983 0.15113752584096 0 +0.120457063547213 -0.201592617382365 -0.0445136993934556 0 +-0.260165111540292 -0.121302230041389 0.314464579239318 0 +-0.255624445330039 0.0158631549542136 0.284844925253351 0 +-0.222048762719648 -0.368139493616356 -0.0589098566948219 0 +0.0967956640316563 0.244674239223987 -0.185044283871949 0 +0.416038600629045 0.149294941083622 -0.226559802277118 1 +-0.185452804412219 0.25991949550483 0.382894664303256 1 +0.225165 0.03527 -0.1156 0 +-0.124904403401457 0.281163368328614 -0.316585363142952 0 +-0.179531071918793 -0.15975873493807 0.358249239557296 0 +0.171272761089886 0.177114648184837 -0.175587150582158 0 +0.302020033019375 -0.0317663615758466 -0.18265944282445 0 +0.236455922535911 0.293754768526993 0.0572708131692633 0 +-0.0513641617907982 0.00236455034173688 0.346843167961108 0 +0.06083828125 0.089498125 0.128561953125 0 +0.414361555158516 0.0671257499625963 0.121164128609071 0 +-0.434189981101438 -0.0446716149326475 -0.0916815425393365 0 +-0.0869382250540462 0.215192571442132 -0.323867136323926 0 +0.067631521435001 -0.219286452609414 0.0877113497204329 0 +0.0153339602013691 -0.337249469684644 0.24250428642133 0 +-0.0236500994415174 -0.0996774227412913 0.332306495902515 0 +0.14858 -0.055805 -0.03934 0 +0.358574682790793 0.237141591980426 0.106762773962162 0 +0.101423507299692 0.0268783770661808 -0.335991711597017 0 +-0.383965418259034 0.256428056891925 -0.187793565842931 1 +0.0763674999999999 0.15368375 0.156533125 0 +0.0950266154605265 -0.351465487341142 0.34011317574296 1 +-0.000161930006974065 -0.205122062126024 0.364688808650221 0 +0.450926745453104 -0.215822989465805 0.00741544376786707 1 +0.181858502433817 -0.234228481862425 -0.260359174173785 0 +0.381892192509314 0.270260104254338 0.173530956930218 1 +0.234226515153986 0.289233989231219 -0.217130438509439 0 +0.197695117793107 -0.113983039967478 0.136760892532391 0 +0.0912640721898125 0.248979071224028 0.31996583069329 0 +-0.287650750814955 0.103434673797553 0.0790310697945451 0 +-0.179316459350815 -0.35842567962595 -0.140409995489491 0 +0.0575413409824596 0.249771814889947 -0.279456985761118 0 +0.193046252340348 -0.251851326824111 -0.0830105960621424 0 +0.463496489567547 0.187468952020867 0.00121714124797512 1 +-0.222048762719648 -0.368139493616356 0.0601648566948219 0 +-0.00745885779071587 -0.211978869963577 -0.452772785231764 1 +-0.394494844551081 -0.267958388435876 0.148772715914317 1 +-0.332083545414023 -0.0274315565405924 0.129150098169273 0 +-0.22919556859725 -0.274851736380227 -0.126109103942156 0 +0.378645028877507 -0.121607965361443 -0.201922445049658 0 +0.14044159767101 -0.0268740365165641 0.409670190315542 0 +-0.0257110220809814 0.190875197570006 -0.36508795933229 0 +-0.192017140080756 0.184247520659136 0.270318352084319 0 +0.32036 0.21996 0.00814999999999999 0 +-0.125082110389423 0.00297365301066965 0.400123112469328 0 +0.0135149999999999 -0.414467775549626 -0.00568642582758389 0 +-0.451692151806757 0.214201064225756 0.00482161242258339 1 +-0.014795 0.14728 0.3951 0 +-0.305266816954093 -0.281675882237684 0.133767083530511 0 +-0.32789630717549 -0.27819228439304 0.0350953691255516 0 +-0.00575101882379353 -0.496765758511693 -0.0556300600353924 1 +0.0655720905427551 -0.495565407208642 -0.00375963635875209 1 +0.347305031948061 0.35387881241048 -0.0449001143390351 1 +-0.349999651059063 -0.352985974042163 -0.025558783645059 1 +0.390083025655752 -0.0411194259032454 -0.180466518417522 0 +-0.00321097652033947 0.490887869171502 -0.0944029466676231 1 +-0.0704291425832533 0.494903501450183 0.00296804532287964 1 +0.0461140686634885 0.0546944529409579 -0.44639422210811 0 +-0.0256820808953991 0.0784372751708684 0.411186583980554 0 +-0.000283929954782935 -0.0506136964470607 -0.425483978480383 0 +-0.0438529047611995 -0.113151204372294 -0.42344540725307 0 +-0.151437399163497 -0.24442662967488 0.233850214326555 0 +0.430315274461483 0.0599172247060488 0.0254317433270008 0 +0.331811095565787 -0.00788004961221822 0.138040916210109 0 +-0.132352558062337 -0.295724175434448 0.283126448717093 0 +-0.221820046316558 -0.205773392110237 0.0391549395899878 0 +-0.425404667328102 -0.0847418681621955 0.0117354161119331 0 +-0.319096705933617 -0.280075766762622 -0.134085822184997 0 +0.353420667961108 -0.0349404496582631 0.262679161790798 0 +0.22715864597399 -0.184956017771067 0.0572828710222478 0 +0.0135149999999999 -0.387875799686783 -0.127414618163192 0 +-0.0235605177628519 -0.291241143795954 -0.169585381780871 0 +-0.284303482241267 0.0260268020679815 -0.330492884246839 0 +-0.0527957852379256 -0.383677904609057 0.23636424784221 0 +-0.202158148211699 -0.111064212226952 0.139968674388498 0 +0.323608299304836 -0.152337989828389 0.0267323345255316 0 +0.177035 -0.144945 -0.16542 0 +0.22313305408606 0.380496116466736 0.0627986880910533 0 +-0.185466769535075 0.205178534427622 0.354117676530284 0 +0.0303752521085413 -0.237278011874847 -0.336042106317339 0 +-0.0158425 0.1380775 -0.16237 0 +0.0339355110404906 0.144068848785003 0.348913979666145 0 +0.239469997567902 -0.158370282818834 -0.282941236097272 0 +-0.018336300892959 -0.344294535497221 0.360327529970681 1 +-0.29646 0.291625 -0.013935 0 +-0.268538679516487 -0.0447738543660944 -0.264260499163997 0 +0.125050925679396 -0.405026338289673 0.0528037305912135 0 +0.176866949413686 0.207392431855784 -0.267958655388564 0 +-0.361768702197777 0.210053132064802 0.128903240940228 0 +-0.384086687712776 0.273875811879212 0.162829334347957 1 +-0.018741619723818 0.270021648158921 0.320618176013977 0 +-0.0416003375784664 0.300462055412392 0.0351790875784664 0 +-0.0660412523403481 -0.330096326824111 -0.0427805960621425 0 +-0.319898900829156 -0.121756959330528 -0.252882081871464 0 +-0.0171732388997255 0.0163788264074164 0.238199488722323 0 +-0.0925702121563207 0.217193681830816 -0.107758893204447 0 +0.0569837712190754 0.416007937648894 0.117776927497281 0 +-0.451194085714066 -0.214342631463232 -0.0223601713351169 1 +-0.109730609216825 -0.0829319278828998 0.019098056588472 0 +0.187023744904419 0.202722870516915 -0.0165974336889 0 +0.0256285391410095 0.149417927063775 0.249419074628511 0 +-0.0913717414769148 0.00691785248785881 0.166188435771749 0 +-0.204537703353857 0.311892478132435 0.135143696551871 0 +0.147368463791989 0.402942267404743 -0.0472909725596982 0 +0.123545 -0.10455 0.0950675 0 +0.42147839577982 -0.0542153002708057 0.0501134106862253 0 +0.0862473292038866 -0.0621761814592938 -0.284074298717058 0 +0.22144042791976 -0.292650177680389 -0.23637555625503 0 +0.0129824091476218 -0.14945822461081 -0.0863167097934264 0 +0.302142362270294 0.240355285298989 -0.219371766725178 0 +0.329724853155149 -0.247718659956458 0.127491519391617 0 +-0.27420457059578 0.224782267583491 0.245963286700808 0 +-0.320677653510807 0.239722274102113 0.0811679287291156 0 +-0.015931925454779 0.176257608623045 0.177709351971907 0 +-0.133742818655474 0.415347988649956 0.0373087077946588 0 +0.40695756515754 0.243678766504057 -0.156987805527927 1 +-0.0806104564990887 -0.276724918345779 0.09716892437638 0 +0.12696955951466 -0.0706866048996667 -0.112046273827427 0 +0.1600614217966 -0.184546112118906 -0.357390981753654 0 +-0.219546582140807 0.357538888643414 -0.132370024158159 0 +0.211842675888518 -0.0684689816216816 0.3885101477871 0 +0.285625114592348 -0.0420449742157263 0.247160096918964 0 +0.212014246323026 -0.308856702961272 0.241413487359068 0 +0.204313089562342 0.13190269814322 0.141101972063258 0 +-0.0839860719187931 0.23208373493807 0.222374239557296 0 +0.118109918670778 0.177785576163778 -0.00997354418170643 0 +-0.0136275299874661 -0.174660162087531 0.148250278931867 0 +-0.101361007152141 0.0842527519765986 0.332441199012231 0 +0.171524613623342 -0.242037521347879 0.255440341413225 0 +-0.188468207902588 -0.052154745054921 0.355093202796309 0 +-0.32215117507602 0.132977170736551 -0.0856459838934598 0 +0.0355580423289209 0.204687882235014 0.308789282109641 0 +0.140703833875292 0.357685002337971 0.0289690909726154 0 +0.13560279831967 -0.310589186133053 -0.284322527034224 0 +0.384929033756397 0.196648502779573 0.0463411477880648 0 +-0.257289947767377 -0.117098049544744 -0.324168565743506 0 +-0.128868070571378 0.262025793791197 -0.147965488978485 0 +0.365873863023976 -0.1051105149966 -0.133538190825801 0 +0.113199279822953 0.110283818874899 -0.134580090640709 0 +-0.196567028086977 0.0775842091082597 0.0138534745766096 0 +0.223568142251974 -0.230971893728491 0.178026891508118 0 +0.333262637230742 0.102973612353024 0.0208658716635004 0 +-0.151076071918793 0.11484373493807 0.271649239557296 0 +-0.0398554533869891 -0.248321249435628 -0.368761329173182 0 +-0.281225821298955 0.202143727478821 -0.196330098173685 0 +0.193944162334582 -0.122992704903644 -0.340094077097588 0 +-0.197224755162545 0.125876237690022 -0.103158104059259 0 +0.0245541844058831 0.374643478929732 0.21077252828816 0 +0.0711962896693542 0.107424636760544 0.424289375531793 0 +0.134654267980878 0.270112870442085 -0.307870683951808 0 +0.0703606762730581 0.494862120200697 0.0073838237793129 1 +0.0814134654638264 0.359350540358983 0.197515791664366 0 +-0.184972255162545 0.0368337376900216 0.108344395940741 0 +0.29238992453727 -0.0198591817836917 0.324161138770158 0 +-0.176445363409513 -0.130407898443241 -0.166856839173706 0 +-0.211978567982393 0.279443730842729 -0.16445298934825 0 +-0.0290322347329029 0.21184264849191 0.371886890714231 0 +0.291999558119087 0.138867699320521 0.278495647739096 0 +0.276306761531652 0.0172072725109005 0.248928054763791 0 +0.170186213856598 0.264158636752342 -0.387716550148578 1 +0.302100135751023 0.0114745681240979 -0.102365968253733 0 +0.0747343491562772 0.329314583589557 -0.287594360337073 0 +-0.0535362712190753 -0.420870437648894 0.127731927497281 0 +-0.109141466164486 -0.0858349529869507 -0.338805906556081 0 +0.1527008716635 -0.0241611123530244 -0.290303887230742 0 +0.114215944372483 -0.220966055519739 -0.315860718230983 0 +0.172874810728185 -0.203783149174378 0.339083647998715 0 +0.07671664922713 0.372666366186557 0.322222457707697 1 +0.144028411472618 -0.321485674792099 0.196657921976231 0 +0.315083475850944 -0.204493885687836 -0.225533707816092 0 +-0.105844147192157 0.156479220826153 0.107888868125998 0 +0.367681414942303 -0.25569753000669 -0.049378002481426 0 +0.252226590197854 0.226552642805017 -0.280614681178263 0 +0.0766553057300671 0.0241925435947735 0.395668976200767 0 +0.253253491835441 0.235224198933233 -0.0023524294778442 0 +0.28790443944308 -0.237702784418999 -0.324474465578304 1 +0.125242514438754 0.127606482680722 -0.293861222524829 0 +-0.257250650865307 0.0479040568621267 -0.255376872011663 0 +-0.274212248433909 -0.250692883695701 -0.327638196451534 1 +-0.35973394552101 -0.0417742409018678 0.214263904514232 0 +-0.232357586834257 -0.32318905467293 -0.195743946223041 0 +0.22992845871574 0.325808897513921 -0.135490696380973 0 +-0.241899692029846 -0.0740339738415775 -0.0663296277053713 0 +-0.0615015954129007 0.0162802574982999 -0.296894431511988 0 +-0.0831603107321824 0.367909940915154 0.325788904634573 1 +0.31887805525379 0.107465560158886 -0.263504404453627 0 +-0.322331335922215 0.0488958993165262 -0.182383323581596 0 +-0.109512214849687 0.300446659096147 0.180820799848139 0 +0.312825022616095 0.357200969571181 -0.153672222487238 1 +-0.174826351379861 0.262715496665752 0.250397584757975 0 +0.0840942868722513 -0.325246035418325 0.0589169999628157 0 +0.32744266726272 0.278108985982524 0.0307034014382445 0 +-0.169434749734569 0.164791895170587 -0.0432386110568658 0 +-0.151466784080982 -0.145179392860533 0.0773395562635115 0 +-0.155434687878823 -0.394508654217299 0.00782222827581591 0 +-0.114313135609538 -0.360047718824447 0.12234596374864 0 +0.333468602864271 -0.132136878809857 0.25780327238407 0 +-0.0749980014685195 0.353943578185188 0.218364435512372 0 +0.286054128310899 -0.102310925731047 -0.241790128092285 0 +0.232128899462863 -0.200206730459882 0.300691813602222 0 +0.250685890563543 0.0385073183447171 0.196938999508001 0 +-0.132906301053355 -0.273301173788181 -0.14607535268337 0 +-0.18181954145605 0.368493861996331 -0.283522183061649 1 +0.269998648658326 0.129190309696941 0.0847479382646764 0 +-0.0587984201402273 -0.259820295449476 0.186650224398909 0 +-0.270436998202826 0.303156037728172 -0.182674264391093 0 +0.103543930126039 -0.367238980607535 -0.208068127475139 0 +0.202365578605382 0.381861012016149 -0.127820885494975 0 +-0.403419309235545 0.006598900372766 -0.0121723218072915 0 +-0.31856771102336 -0.190469091708207 -0.184484550818966 0 +-0.0775190380770229 0.172797551507148 0.167517209006527 0 +-0.420042615855921 0.148841231892496 0.220141181702152 1 +-0.324318123471861 -0.241606470825847 -0.285373853866469 1 +0.148955433133627 -0.259555468015334 0.400217509018135 1 +-0.207600725054046 0.241720071442132 -0.279404636323926 0 +-0.117697080895399 0.00811727517086847 0.279416583980554 0 +-0.00385512099304935 -0.317965072154085 0.0851509916033864 0 +0.0264773770652469 -0.259853949885126 0.274457047822626 0 +0.0566878309666201 0.233637215155023 -0.0296613804584625 0 +0.129241807863735 -0.270622824175063 0.104545059974932 0 +-0.0751542399708353 -0.161153286237878 0.27920838138416 0 +-0.0131955591763878 0.326428654373967 0.265846781516606 0 +0.190815827004555 -0.269372439991089 0.0669459591999787 0 +0.199363331654966 0.24978425137924 0.174750119424542 0 +-0.315570684303762 -0.249244242676588 0.211876414899781 0 +0.0717476282649075 0.188838004996521 -0.106775488391403 0 +-0.0421159043410953 -0.357899083058548 -0.343588879969799 1 +0.0767320355913114 0.204670708671404 0.222122136557923 0 +0.317629583810525 0.0262412796626935 -0.287612006024664 0 +0.388861285632685 -0.0545202153485711 -0.0331170115168565 0 +-0.0753876817047564 -0.145823949221621 -0.0866759195868527 0 +0.066795050561227 -0.0697916149361451 -0.0361000832693459 0 +-0.327814630770729 0.262196878247963 -0.264267212847603 1 +-0.139659095412901 0.1536777574983 -0.295216931511988 0 +0.00112206148507255 0.340229265374487 0.364407408196767 1 +0.268492805990735 -0.133491478985762 0.181911388045176 0 +0.337986875195897 0.122119803569762 0.227674946085914 0 +0.32254416837724 -0.264899360247359 0.268224532866884 1 +-0.242278332168384 0.240399117401781 -0.099824811005571 0 +0.401351512255312 0.0282738366118361 -0.136678863344674 0 +-0.0663649852227108 0.180161415371532 0.274306739345437 0 +-0.0574716125270232 -0.157183785721066 -0.253663568161963 0 +-0.215794524459185 -0.318410928632244 0.127405223795048 0 +0.0765734556163776 0.113499331225739 -0.217098526527573 0 +0.0402822265625 0.0803610546875001 -0.10105203125 0 +0.439517635751023 -0.00616043187590215 -0.0445659682537332 0 +0.224305903414263 0.254902047145782 -0.0759317252140246 0 +0.00550845192861638 0.0212153125162439 -0.214421638952675 0 +0.279888582600717 0.171864018401787 -0.213985335051852 0 +-0.26236269894129 0.260067588075529 -0.330664091368195 1 +-0.0340470294802985 -0.0646353665031372 0.494822794722961 1 +0.0543176880053428 -0.353918318858149 -0.34601965612999 1 +-0.253193479975168 -0.301791859744626 0.193306991736636 0 +-0.209569852484786 -0.0484498295755663 0.275586387001085 0 +-0.229026118302886 -0.222671720184357 -0.219143105946513 0 +-0.0466171471158898 -0.213091367471343 -0.123334743874408 0 +0.277184054172287 0.280050311911735 0.194226651963051 0 +-0.414305041113521 -0.0140251060046275 0.0666570916008307 0 +-0.169288407987392 0.348944750598391 0.314350904282818 1 +0.261704768733518 0.058686154706438 -0.322434753004853 0 +-0.206314318062318 0.296854556286591 -0.241748907134085 0 +-0.388550396865914 0.073345851303281 -0.156808450836489 0 +0.114717738126743 -0.305090837313182 0.291258010059651 0 +-0.268000660404209 -0.225231811752019 0.200848388795431 0 +0.181291711794827 -0.36911094359902 0.283067529114793 1 +0.0714930910634189 -0.0469561641462222 0.0599278925741586 0 +-0.0883003727009632 -0.0342362829883999 -0.391928348110039 0 +0.118516614499982 0.0667380481820328 -0.0263686086960428 0 +-0.247900225304448 0.338339208294411 0.271468967603074 1 +0.167371321521328 -0.347682085911097 -0.316541885730471 1 +0.0245067619077868 0.0791973107790332 0.295289137557878 0 +-0.0180914034992826 -0.309821144681899 -0.315152482248043 0 +-0.313120513976031 -0.0935799365790518 -0.0776914756434839 0 +0.211260029123412 -0.0600137338380676 -0.139202301028887 0 +-0.099221508802863 -0.0723607084964868 0.393549716035239 0 +-0.155344815071797 0.177464765035554 0.0328349167579433 0 +-0.180195752940632 0.127074340885301 0.363391942202298 0 +0.311028564458389 0.245708997684173 0.23465116056954 0 +-0.171023095934329 -0.206182191644098 0.300087677642383 0 +0.161310870726181 -0.327983891195992 -0.0155559675513729 0 +-0.0376591125270231 -0.218771285721066 -0.206828568161963 0 +0.061831925615323 0.332786868858098 -0.191824420310875 0 +-0.383945733013472 0.0854349876900216 -0.0610818438384968 0 +-0.167847713689822 -0.266994785551828 -0.215213900078247 0 +-0.146270744330642 0.160685461940916 -0.367547138922855 0 +0.0346130815622276 -0.409538206737976 0.189594580105536 0 +-0.274913137906362 0.0508043442250539 0.0113059898518519 0 +-0.0605829737781765 -0.371609696085241 -0.171856818164153 0 +0.099951498352595 -0.134382997119549 -0.0771167600644063 0 +-0.288523330220943 0.297452121595286 -0.0990483065797553 0 +0.111698413356446 -0.0151413521067763 0.321168219800764 0 +-0.11927766816148 0.0586616411926625 -0.11864219627056 0 +0.17224895179573 0.1484085230208 -0.0801330397000255 0 +0.119499052433102 0.384997925076284 0.135982304167363 0 +-0.2483775 -0.0407475 -0.183895 0 +-0.114700128166358 -0.0973241476771215 -0.148877718642968 0 +-0.123111545003789 0.295148436063046 0.0771329391606439 0 +0.279213818615371 0.0691218061765122 -0.0473670641682498 0 +0.263102013013799 -0.0946028554025029 0.321603270365215 0 +-0.222901165440806 -0.292406639668711 0.0560482346109225 0 +-0.0370942023585313 0.4494481972782 0.0365342492400947 0 +-0.179093875519737 -0.0637314492216206 -0.247631311383515 0 +-0.256312996785897 -0.111417446540361 0.0757145537243333 0 +0.209527610199651 0.0314784221728235 0.101874041087053 0 +0.0249867505653611 0.00580105583848101 -0.0950484535697642 0 +-0.215200915694353 0.384546431498008 0.136115805097242 0 +-0.155537976030959 -0.252360977311357 0.156304399080578 0 +0.369875271502047 0.0537666362481957 -0.0618769365074663 0 +0.0532205530568556 -0.254897165413041 0.00988352733673636 0 +-0.33012223591006 -0.158899580617795 0.250625477405144 0 +-0.1088675 0.2025275 -0.04422 0 +-0.265842277783006 -0.193967156403059 -0.0926462975542464 0 +-0.106367905847135 0.106146068837249 0.0530410118689777 0 +-0.128183431277421 0.0295384121442973 -0.42673752130609 0 +0.224849508628769 0.179134188228307 0.257286024199254 0 +-0.25936686343125 0.325736701840852 0.167957382282361 0 +0.387203660075562 -0.123969669642933 -0.0430083340369069 0 +0.32057328852382 0.274259325841285 -0.0544751862496842 0 +-0.126262789227881 0.0591727574982999 -0.35391232330865 0 +0.326271578550249 0.0786471816817611 -0.114863205219015 0 +-0.367247787645159 0.242214164781093 -0.0495419434757557 0 +-0.399754626520456 -0.106439846274133 0.188505299353967 0 +-0.262089577298336 0.00769041346269439 0.359870309248953 0 +-0.165467485882204 -0.350934555478499 -0.313879391713764 1 +0.232948126170174 -0.185085663412055 -0.0878652980310712 0 +0.141394325057695 0.211099717035595 0.169166070625465 0 +-0.07616290402059 0.336113848431303 -0.281095693067725 0 +-0.415191117185914 -0.166540292279581 0.0278874384317848 0 +0.265127336422355 0.331957605398832 -0.0350775440934692 0 +0.152959791105716 0.163117645551475 0.215909701743059 0 +-0.172972379921621 0.259243195669121 -0.000752205967487207 0 +-0.0242343324142987 0.408117485084633 0.14558012121939 0 +-0.201120767255368 -0.248217487443556 -0.0381998504274411 0 +0.0234592461271794 -0.232637264069782 -0.0623448289874279 0 +0.166326729598493 0.289670541957291 0.105427633125465 0 +-0.340915216790592 0.108430022575857 0.00221099695946492 0 +0.0505701980536276 0.180753781683075 -0.386907993642199 0 +-0.021811339726758 0.289432688780968 -0.336596164827392 0 +0.229883257883194 -0.176033052406196 -0.0178556657562173 0 +-0.142308215016 0.000484473389523288 -0.293535003897999 0 +-0.0427820474214266 0.427751577800993 -0.0896003376611521 0 +0.171703279615962 0.243176566717861 0.257966902765002 0 +-0.0293603124262244 0.0688837287465173 -0.0577596035620461 0 +0.190979328820481 -0.00178634222316665 0.353204188947548 0 +0.0209913593099936 0.239343277251852 0.128091282806265 0 +0.0757075 -0.141645 0.19704875 0 +-0.236026879055246 -0.00120606791312211 0.171850721203623 0 +-0.2818372583681 0.139894119096016 -0.273702670534621 0 +0.27663845240713 -0.367990719115471 -0.194208101101455 1 +0.148886331392908 -0.0753605948657129 0.240329207841284 0 +-0.026755 -0.1174625 0.04812625 0 +0.0415241565375111 0.131072202133552 -0.0217791984593076 0 +0.393345017341593 -0.265748706592974 -0.15477668685498 1 +-0.219330746097926 0.383850110373352 0.0724853376395446 0 +-0.0597291203219472 -0.31357642143195 0.263093493064677 0 +-0.0193255135137897 -0.282503270927431 0.35773482330044 0 +-0.140384143635574 -0.131645578903873 -0.300623008937267 0 +0.0123746381252998 -0.0279604274273623 -0.291254159371365 0 +-0.147105482242416 0.363970541312939 -0.20211993471964 0 +0.309117809703448 -0.143406154665992 -0.163734952479772 0 +-0.0263557733173641 -0.00361307379613229 0.429002641462678 0 +-0.017969296875 -0.035999140625 -0.1579040625 0 +-0.231190781397445 0.0627782986225655 -0.135653184895744 0 +-0.256737621586755 0.111877877267461 -0.189135728874482 0 +-0.180334846014923 -0.147231986920789 -0.0319098138526857 0 +-0.371068397192911 0.236530022599239 0.0241166556798018 0 +0.277197789226746 -0.305246992887753 -0.125701457185261 0 +-0.24340590182296 -0.165372740314395 -0.274422743882088 0 +0.159712610387549 -0.244380116647445 0.00268067646045889 0 +-0.100227590852378 -0.0371257246108103 -0.0971929597934263 0 +0.191849772047833 0.21380340377996 -0.337703453861421 0 +0.258044026526903 0.157876607778077 -0.0748963549495724 0 +0.199162042170529 -0.0066860834777045 -0.206181427100603 0 +0.367047143298097 0.0289458242895424 0.0487426772360072 0 +0.271788388039324 0.0566422252125431 0.130991456986429 0 +0.166344236401867 0.0277132011074167 0.185101886127311 0 +0.0111134324108806 0.257999730061407 -0.162896844569105 0 +0.14335970507242 0.304241115956189 -0.161529208969261 0 +-0.0746712757273063 0.203269872721914 -0.196416301942646 0 +-0.247546186321742 0.134871970247873 -0.00709219862040117 0 +0.294768903269366 -0.169053877365931 0.121020519993523 0 +0.143853310979153 -0.137596894277014 -0.273897355273178 0 +-0.197253368782224 -0.179147612018396 0.220979487725862 0 +-0.0449249826158912 -0.177795900027372 0.00483145480048464 0 +-0.287122924234103 -0.332335055852922 0.0595113459873117 0 +0.346429076903836 -0.206395682856561 0.182873384305593 0 +-0.259169417479321 0.0847856160464443 0.270225083367391 0 +0.0221825 -0.0891175 0.0989074999999999 0 +-0.0540630355336377 -0.242004361688824 0.281653131570314 0 +-0.186078361659181 -0.063934543948903 -0.319437173464229 0 +-0.0975667859593966 0.072413117469035 0.252734619778648 0 +0.0280115549828778 -0.0134569656698594 0.335411665091899 0 +-0.124917219126457 -0.153810547131351 0.199578727106126 0 +-0.221124565911773 0.219863785400074 -0.0316701214964046 0 +0.136745541491485 0.128873620538651 0.384707047905724 0 +0.00313213469303952 0.00799308109381347 0.141618833741413 0 +-0.22587015900663 -0.0478780022967967 0.101192338542534 0 +0.044578001015562 0.184143544199472 -0.1841291244208 0 +-0.0585055326351367 0.131335925924173 -0.312287728144135 0 +-0.192363745268225 -0.331735377558401 0.208009164822945 0 +-0.338735426329208 0.0683645687542791 -0.259386832325419 0 +-0.164643313676672 0.199464139865995 -0.131665967039036 0 +0.173673263867753 0.1076268299058 -0.355163612108506 0 +-0.263446150231102 0.0379997903968339 0.0976044739131018 0 +-0.139746986519504 -0.348903791077206 -0.21756465154382 0 +-0.129678755893467 -0.264696858008463 -0.320745061656071 0 +-0.233505545744779 0.0883467163912831 0.171685066701598 0 +0.263619264240645 0.103242975479167 0.225404169810067 0 +0.040113980681266 -0.23025255262112 -0.219215047910441 0 +-0.00105933619974541 0.0810671363899637 -0.268024973620474 0 +0.211046868044729 -0.0262326591076122 0.280079214040277 0 +0.276933302642383 -0.266566566644098 0.0077309229032575 0 +0.345244784024074 0.157342464298064 -0.147692899130575 0 +0.267656271658131 0.0701447240210824 -0.198651833787243 0 +-0.209346481306824 -0.192087040407541 -0.136578809832889 0 +-0.274180263557725 -0.179799957522809 -0.00781641948203926 0 +-0.36122140097458 0.0200329373482846 -0.104376005629295 0 +-0.241607285149315 -0.221780781968755 0.129871640329418 0 +-0.394779322514289 -0.00646014269286094 0.157155323726294 0 +-0.225651355308954 0.245815144823771 0.0536769202715908 0 +-0.297388570151462 -0.159912347777729 0.100175001573269 0 +-0.0636891773251356 0.0854050624152562 0.158788499360028 0 +0.0961819073012176 0.116234074106351 0.0562127336603597 0 +0.254918612813808 0.142753828144217 -0.327033744619975 0 +0.108285059528934 0.16063074629237 0.292886510466432 0 +0.12401674971416 -0.207167903960086 0.0489845495258384 0 +-0.0638366672595626 0.0401854930892512 0.0807787096628277 0 +-0.288602851505619 0.296129317311796 0.123782003206663 0 +0.204292687583515 -0.323149560529968 -0.145922877694791 0 +0.2599925 -0.100705 -0.0203825 0 +0.0517906562782057 -0.354687653648221 0.156386848402491 0 +0.138649624745787 0.0142154440054705 -0.397785245564055 0 +-0.0347745861719956 -0.0066872392626432 -0.362522807341301 0 +0.137997794413002 -0.045355625009864 0.145056541315371 0 +-0.102881406784321 -0.38846848000256 -0.107634707403793 0 +-0.350535170038463 -0.192017922134351 -0.0835341712044145 0 +-0.036761727655763 0.0479911556581916 -0.425998365030241 0 +-0.0370890179796983 0.109639996234517 0.244168091139324 0 +0.0139086024103424 0.0456267720495993 -0.378180166277236 0 +0.169602058251014 -0.249247449617918 -0.164418974315021 0 +-0.354895733013472 -0.0715900123099785 -0.0151643438384969 0 +0.0910766508241094 -0.272235113782355 -0.232321412402963 0 +0.186288289256277 -0.0145044161343466 0.0302053261545451 0 +-0.118512205328259 0.141350077050018 -0.0842977896780525 0 +-0.141460071758576 -0.218142934086067 -0.107117623006869 0 +-0.125453658472948 -0.444340524353231 -0.0436924250497699 0 +-0.357521017302019 0.0379264810726121 0.077759063650545 0 +-0.0974206104956647 0.185946172486397 -0.393942213922422 0 +-0.243214907044149 0.296233545793729 0.220857886605171 0 +-0.331080083271973 -0.0566980686430574 -0.157711041208804 0 +0.269534899811509 0.170418645210128 0.163149500482775 0 +0.019161875 0.0686990624999999 0.18989421875 0 +0.283194873429569 -0.215986348723844 0.226157003497505 0 +-0.174984695653823 -0.0526577283010488 -0.137029535484181 0 +-0.326816942083954 -0.0829585593203737 0.263727510917991 0 +-0.07935875 0.22543875 0.03461 0 +-0.0279022904476995 -0.0291026124145658 0.278378291990277 0 +0.0971848852077026 0.00293504298054181 0.0074275466838627 0 +-0.00461583925306053 0.336724501484719 -0.367788476712677 1 +0.334006348423036 0.0509164302648988 0.273391211552465 0 +-0.16135507974863 0.334889770175231 0.222600413567881 0 +-0.33422167627153 0.0887860007824428 0.268179079031429 0 +-0.127386843676115 0.0150491962967912 -0.000125626397326384 0 +0.197297282080976 -0.0583396361401363 0.100685406650724 0 +0.0339329208384241 -0.0636048748696753 -0.22505544393682 0 +0.416567522795605 -0.126690142433392 0.0150218142946372 0 +-0.297486970986258 -0.357884122341467 -0.180484509669251 1 +-0.109129301764179 0.295937485495172 -0.212717768847678 0 +-0.0416275716746874 -0.0701067292180291 -0.288340414140185 0 +0.201521288144962 -0.380223297481688 0.116528788125798 0 +-0.308386040360371 0.244045086701353 0.181392114696978 0 +-0.204180102792567 0.134715589860882 -0.345426788679545 0 +0.152880625 0.015918125 -0.1397475 0 +-0.100473479035747 0.128293620612631 -0.158765517241186 0 +0.388862980360384 -0.19765042470585 0.0630659778482073 0 +-0.338123989260062 0.130614177137084 -0.182014259964483 0 +0.332819409307685 0.00498090308825616 -0.0468635320841249 0 +-0.0178303625270231 -0.284742735642762 -0.244833472702761 0 +-0.110218091003391 -0.0194302993779244 -0.174906428870819 0 +0.0742269135781883 -0.0436093637061767 -0.428027484221403 0 +0.0612303404664346 -0.0536222122781523 0.418999396977695 0 +0.341249957280686 -0.0654329730535815 0.034210813462151 0 +-0.207930324710992 0.00398245473718939 -0.382114314131138 0 +-0.14880311229408 0.227288664043857 0.133352636621263 0 +0.172218722524829 0.0345139826807215 0.277632514438754 0 +0.132079593324951 -0.380290427489502 -0.145875875831384 0 +-0.362494045420498 -0.173974852240036 0.0697676115340565 0 +0.29591694133481 0.285519164303386 0.125422810008962 0 +0.104958354329936 -0.30429528024166 -0.0980257343862915 0 +-0.238560508287711 -0.160374630448583 0.163550820328321 0 +0.398719751306077 0.134102519244065 0.0569261457006935 0 +0.246476257219377 -0.00866675865963928 -0.287353111262414 0 +0.182278815254758 -0.123498561846306 -0.0721750978857666 0 +0.303927610881033 -0.0645027655611363 -0.064035940692963 0 +0.12876772636438 0.252405470728904 -0.0524116164102052 0 +-0.174442559770957 0.00832652374857168 -0.0614434507650233 0 +0.0705474184415188 -0.0852962843897821 0.293462160711878 0 +0.262850149092517 0.114010665899579 -0.136774094368408 0 +-0.0130853600203181 0.179833514086253 0.0315729713675925 0 +0.202301819881518 -0.301048077940436 0.144949583393043 0 +-0.162499938066345 -0.269090257706316 -0.387765037039442 1 +0.2790321770416 -0.0579049184057509 0.114122854439374 0 +0.00739517644205512 -0.161536933735672 -0.204144871937204 0 +-0.33112357538134 0.0929942943807052 0.179552223789438 0 +-0.28160036267671 0.173679864412541 0.0623879461659149 0 +0.160754914333038 -0.120203634717855 0.0233267061087282 0 +-0.304706056699571 -0.341519344174233 -0.0973672223808967 0 +0.0448208414351181 -0.147890271793987 -0.413409411673849 0 +-0.25259103968525 -0.138761109876373 0.239621869701052 0 +-0.161320848727772 0.101901999981459 -0.182818143401228 0 +0.0724954660235317 -0.130488756770471 0.0292070490637621 0 +-0.132076127581272 -0.0184256311549892 0.10554594797037 0 +-0.165006499077821 -0.0774068573547865 -0.390269212397597 0 +-0.287185320800119 -0.086204703940259 0.162375737603341 0 +-0.277817287028767 0.105088747867313 -0.327770344838152 0 +-0.0728189445602197 0.28622857822021 -0.0370286406893063 0 +0.264520306255623 -0.2905198545084 0.190995437343358 0 +-0.0957543063711833 0.0837139388926429 0.43721542370942 0 +-0.141097228805749 0.240082893688269 -0.228769628204088 0 +-0.149194737694407 0.161048728655492 0.195696017844977 0 +-0.292198678944876 0.162774072420098 0.132302918588203 0 +-0.274821884758905 -0.123619634600187 -0.170415337588717 0 +0.261021508444375 0.21965113127774 -0.146067993052074 0 +0.00867366956060223 0.297680720511791 -0.245650532749836 0 +0.00325966127496669 0.374787322261792 -0.241415020715629 0 +-0.0379587954261891 -0.0152078623054052 -0.0415764798967131 0 +0.382982010453474 0.189298599596822 -0.102657513668299 0 +-0.277828806110651 -0.297960718085415 -0.029978548001014 0 +0.412010643877912 -0.035769989307246 0.124727317966762 0 +-0.0455660666058959 -0.366451193626664 -0.239333639487813 0 +-0.184945055551038 -0.38424751259229 0.14479687876966 0 +-0.134712988017407 -0.181290163725544 -0.229232290524115 0 +0.0616997085891655 0.280365112545176 0.243839820502311 0 +0.042574140625 0.0481040625 0.0713009765625 0 +0.253292097481565 0.0548879737511853 0.327733615039347 0 +0.05645703125 0.0508235937500001 -0.177950625 0 +-0.00254931597739078 -0.176480787826755 0.218616742874067 0 +-0.145025612087986 -0.0781327056239829 0.153335573569675 0 +0.0208200455642031 0.302168170188215 -0.107839902642355 0 +0.0597887889145927 -0.261599115431569 -0.141507538803076 0 +0.220296329659095 -0.334742113153451 0.0695656951450347 0 +-0.118491329738295 0.0795280430281318 -0.0283792512685185 0 +-0.0285997335112761 -0.312917968854824 -0.0960714379938449 0 +-0.235502320733601 0.229193235148776 0.159146137794686 0 +0.0800036841635003 0.0699773251469756 -0.276285137230742 0 +0.150281606812554 -0.172201174294728 0.262680143167992 0 +0.406644184953544 0.166360136702453 -0.0189171399608238 0 +0.164613411637442 0.0564865415437602 -0.264353771290094 0 +-0.198309777521168 0.123530219482014 -0.252786819345996 0 +-0.0809966192308708 -0.173896390911354 0.114323857799993 0 +0.02350458744438 -0.144921822832924 -0.287243587604881 0 +0.29152700942743 0.197847889449135 0.0547063025635616 0 +0.291571408065942 -0.144124549103504 -0.3045284386611 0 +0.1868725 -0.0102675 -0.07747 0 +0.0924701826295005 0.0924116449435717 0.3442777433336 0 +-0.19487031686355 -0.0857658233068183 0.0126419964711532 0 +0.0839037475511769 -0.217957277329635 0.246051694366664 0 +0.0939163990155357 0.280996581706028 -0.124475938085087 0 +0.277348096976021 0.0169781480062643 0.0297855057098884 0 +0.04532125 -0.075556875 0.1706178125 0 +-0.393417179723242 0.0060549968673782 -0.175582875078097 0 +0.101294337939069 0.0277229584664134 0.132472933101136 0 +0.0565203292667452 0.333509795171459 0.289876862296487 0 +0.100624338448776 0.00749050262714035 -0.0940395096387263 0 +0.16936234375 0.12816359375 0.04176484375 0 +-0.0356423977823031 0.0781446074561261 0.0168666853929913 0 +0.101164745753599 0.337209083094907 0.0911034194242839 0 +0.145498153756561 -0.305139442475401 -0.189876506296552 0 +0.119991186762866 -0.206435139224548 -0.207008121348858 0 +-0.0816047898297982 -0.276447058160062 -0.210422489725332 0 +0.0933790317462668 -0.130349568124098 -0.351842635751023 0 +0.264530098131387 -0.0180352520081781 -0.364928910187335 0 +-0.416422324886131 0.15267642784915 -0.0305231051130897 0 +0.15527074425669 0.24362115078792 0.335320271643807 0 +0.00114032011646215 0.0849698330382676 0.49275371115474 1 +0.262008167199678 -0.260857176582167 0.0938204178531218 0 +0.105587893697125 -0.0995225632445061 -0.193589487432685 0 +-0.04015875 0.13766625 -0.093585 0 +0.19751817423175 0.0287004847084564 -0.355817757622485 0 +0.186346176722125 0.095511855850307 0.216327966796068 0 +0.0835570772796157 0.191832777237052 0.0761400072870677 0 +-0.0614137499406466 -0.0580704862265002 0.451351674113648 0 +0.1654621601223 0.0611451175924945 0.398331614030674 0 +0.209774864802955 0.080839987146428 -0.0389582649204724 0 +0.206384026094802 -0.391984176173469 0.0454180022821378 0 +-0.0644134405320561 0.307894496365059 -0.114702628631181 0 +0.105532355724315 0.187584319077182 0.374575489561072 0 +-0.0416481660835884 -0.0980623531831888 -0.1316607960812 0 +-0.387840672796425 -0.144507319467156 -0.024887401571231 0 +0.367283265733607 -0.144781815507009 0.200881279342442 0 +-0.0457058389709236 -0.0158417670310245 -0.439810229836087 0 +0.354585772736626 0.0425485065720904 0.196869297716722 0 +0.036436538760873 0.244039682173122 -0.366056946680257 0 +-0.254033795340455 -0.0488118749196267 -0.345343467884125 0 +-0.0379898928888605 -0.0314426722909877 0.0650523712516864 0 +-0.0141073734714013 -0.118983703263927 0.4378806426339 0 +0.088904896478408 -0.299812078535106 0.224818032456354 0 +0.147706459243438 -0.204678654841343 -0.117793648462196 0 +-0.00683879909934126 0.166019834801082 -0.237557592399269 0 +0.184329261434178 0.286295467733617 -0.00260432554588141 0 +0.0314059538494055 -0.0693153764652026 -0.110366208698357 0 +-0.498223000671082 0.0414499560818616 0.00833137742553569 1 +-0.0892397546454277 -0.231424102653449 0.329552515509103 0 +0.0963761627557981 -0.0156175204388886 -0.190460254828378 0 +0.255742615814709 -0.354813332962879 0.00459970959759426 0 +-0.245845151424224 -0.197011406569096 0.278405974860509 0 +0.174287455946238 0.10730871163254 0.307057767114304 0 +0.0792724646607385 -0.0128564971994732 0.225076511142538 0 +0.304520567758921 -0.315112197195644 0.0592467366762093 0 +-0.199056430178002 -0.0854433013498072 0.205541348413608 0 +-0.0445558929796983 -0.0718231212345175 0.172490591139324 0 +0.350669740042091 0.0844043757423679 -0.186829283110769 0 +-0.420586036393489 -0.071889196861577 0.101407100280838 0 +0.375999424544668 0.230274962954258 -0.0377826585425576 0 +0.297722848449148 0.287018559745275 -0.124938993095469 0 +-0.195271939888005 -0.211156892908919 -0.304929288784661 0 +0.0996873465623522 0.104602194709675 0.221470282361371 0 +-0.137276038950573 0.173690089302759 -0.230852379609823 0 +-0.356534615844824 -0.271952030446366 -0.0547407427004336 0 +-0.373607324614406 0.154712874196136 0.0741866904244622 0 +0.338136947827522 -0.303945094704171 -0.00284769669786439 0 +-0.203569297064873 0.138897542655551 0.0995448854017379 0 +0.113423767646694 0.271287401595928 0.0251256429751584 0 +-0.431902631169651 0.0511563262730753 -0.0877274957238362 0 +-0.0249245751574791 -0.183098398329794 -0.366999485906442 0 +0.00416373810813442 -0.172630044092543 0.0671603368258346 0 +-0.147744731216949 0.0822983846738659 0.175281779675441 0 +0.0665195968682442 -0.189528446430266 -0.142507142040491 0 +-0.229540936222725 -0.269742673467241 0.27086804465354 0 +0.199180359231758 -0.151064833426847 0.21667023725292 0 +-0.288996782815502 -0.255883038148798 -0.210671352861431 0 +0.166947729778523 0.0609173185072732 0.0491468162995012 0 +0.19886472946175 0.257161142911596 -0.167989796641126 0 +-0.238620563254652 -0.0210648250739627 0.0184267142381489 0 +-0.0431497774476812 0.0534183266405188 -0.139436878531999 0 +0.364804489593241 0.0277658617224528 -0.228712904277685 0 +-0.0232934339946416 -0.232206662808423 0.0854424545558664 0 +0.290690754222187 0.21980556563887 -0.0689589965260369 0 +0.130848219137554 0.113090230231307 0.13805412887159 0 +0.209694184447589 -0.351945793496427 -0.0734730941467521 0 +0.23939971197826 -0.139747847417378 -0.201497424198174 0 +0.0339892083511588 -0.38784841546604 -0.214804774607898 0 +-0.318067269440471 0.0354186407866692 -0.0465350078887216 0 +0.336843418392215 -0.0631500558229761 -0.284856136259329 0 +-0.116649053670284 -0.0466156002256657 0.222169096108693 0 +0.275708764819312 -0.116652310142014 0.256712618884862 0 +0.382873685754993 0.119919129745434 0.183404520469906 0 +0.2090676516884 0.225849465466312 0.312224657110491 0 +0.172577804574718 0.0697292270649046 -0.101764410887527 0 +0.0436306907261503 -0.0351213260667055 -0.362195966916424 0 +0.254874622068364 -0.214645279395892 -0.154436682250546 0 +0.197169080333549 0.318423961998839 0.234994309770625 0 +0.235337662404766 0.248256404899534 0.245485024469033 0 +-0.358043849681898 -0.0950822669527149 0.0641607907570889 0 +0.24692920425105 0.342384081264336 0.266473349985615 1 +-0.0498573414341429 -0.278925390379024 0.0186875499204993 0 +-0.253250454172746 0.136981990234952 0.311733004315698 0 +0.0138238095399292 0.204678964504809 -0.308391035597635 0 +0.0167870845523004 -0.0818722999145658 0.246777198240277 0 +-0.139114055802422 -0.141750321537926 -0.37750639027978 0 +0.209968937113884 0.0902955645758421 -0.192590338719254 0 +-0.196197836561104 -0.28754457058319 -0.27125435355597 0 +-0.123971567675218 0.0790172497830465 0.117925839575655 0 +-0.279992509024221 -0.0359078016754509 0.229688107828018 0 +0.0313735818595634 0.433067377337693 -0.0910634886182659 0 +-0.203709205872106 0.061957767186781 -0.316239494672794 0 +0.239516355816945 0.337014192560145 0.148741448028539 0 +0.198462553753103 -0.385593721717808 -0.123081610599848 0 +-0.22315223660989 0.0760391183396606 0.329404611221114 0 +0.20281196483593 -0.142973870740044 0.364991517793425 0 +0.0371029020413953 0.259884899559028 0.369111486399881 0 +0.0415149570794683 0.0294159877121776 0.44781717459184 0 +0.124393647064015 -0.0874774865739985 0.352068836382005 0 +-0.0127721255107199 0.215565758109004 -0.095590667152241 0 +-0.356609977250668 -0.119186485962017 0.19889991655587 0 +-0.17756283758209 0.0364706512940501 0.288661697954751 0 Tetrahedra -9516 -1051 1403 728 976 3 -2 1895 850 1762 3 -46 1149 1084 156 3 -808 24 1936 1404 3 -1605 683 1076 618 3 -986 1722 1262 1089 3 -824 435 1349 897 3 -455 918 45 1276 3 -84 466 955 1674 3 -930 1315 1645 1283 3 -535 1029 1267 749 3 -314 923 769 439 3 -784 1226 876 989 3 -1530 1109 1606 776 3 -1718 1384 36 514 3 -317 1719 491 319 3 -1425 1578 723 1441 3 -635 690 476 1085 3 -1015 676 635 476 3 -1943 1430 1093 539 3 -1306 1307 1528 1037 3 -483 800 1151 39 3 -258 1061 1761 1321 3 -1924 1791 913 1848 3 -577 837 1886 1511 3 -106 286 1125 130 3 -114 502 1357 131 3 -1040 1431 1570 1370 3 -827 195 1957 962 3 -1690 932 1693 1096 3 -89 88 559 55 3 -81 272 241 1214 3 -685 511 541 648 3 -1112 125 855 1548 3 -773 769 255 1874 3 -1744 1636 1089 1840 3 -1349 1690 160 435 3 -697 766 1020 1675 3 -1036 677 619 491 3 -114 1357 1387 131 3 -241 81 1214 311 3 -1793 901 1675 1557 3 -1247 804 514 143 3 -295 1888 296 205 3 -697 766 1675 716 3 -1796 1890 850 5 3 -1231 1535 1308 1812 3 -1807 86 520 562 3 -894 1338 842 1058 3 -939 894 679 842 3 -963 828 1395 899 3 -654 878 1792 1630 3 -1942 1430 324 331 3 -1381 1154 1525 1103 3 -551 1936 667 368 3 -383 1865 1470 832 3 -592 984 784 1751 3 -230 978 511 685 3 -711 291 670 1219 3 -1189 1015 929 625 3 -50 57 1850 113 3 -323 730 1613 631 3 -929 1189 493 1015 3 -9 902 665 1328 3 -507 1491 812 783 3 -401 1911 379 420 3 -166 1066 20 1299 3 -1592 1528 1665 1202 3 -871 1194 1122 25 3 -597 1494 33 1620 3 -1338 573 1255 1627 3 -91 364 90 746 3 -275 241 1447 311 3 -1267 749 1142 539 3 -265 199 230 685 3 -269 283 911 236 3 -254 100 54 512 3 -1943 539 659 1142 3 -1889 892 65 1312 3 -1206 598 509 847 3 -236 557 208 283 3 -1890 1911 401 850 3 -1808 1806 289 201 3 -1723 780 11 897 3 -276 518 1791 1573 3 -28 1807 261 1022 3 -1366 989 784 1002 3 -1497 43 158 192 3 -1585 1682 1834 406 3 -1499 1760 903 356 3 -1024 1282 1556 1477 3 -805 1629 1306 1307 3 -1512 1511 692 510 3 -761 901 1122 596 3 -727 516 1553 1272 3 -1451 363 1167 857 3 -705 827 1417 1657 3 -1282 964 1531 818 3 -1567 981 1145 294 3 -1808 1806 201 931 3 -182 180 642 574 3 -1335 468 1926 8 3 -348 531 578 167 3 -542 829 786 1326 3 -991 925 853 537 3 -880 814 312 242 3 -275 579 223 302 3 -789 1279 915 510 3 -65 632 745 927 3 -1171 1807 560 562 3 -290 1397 135 1083 3 -430 1758 493 838 3 -1114 27 332 169 3 -763 471 1340 933 3 -91 746 476 690 3 -1404 24 1936 1315 3 -1646 910 668 1457 3 -1766 1008 44 648 3 -91 90 248 476 3 -109 596 1067 218 3 -143 804 514 885 3 -484 3 793 474 3 -111 110 1219 940 3 -284 1879 498 611 3 -550 1154 671 1245 3 -71 1437 1696 1391 3 -257 849 1906 85 3 -605 1740 912 868 3 -1935 1319 572 721 3 -557 514 869 1150 3 -728 1403 597 976 3 -126 1476 1246 285 3 -784 1637 448 854 3 -539 659 1142 552 3 -937 992 816 572 3 -731 1501 1577 443 3 -988 449 319 1263 3 -1214 1924 770 1848 3 -431 614 1051 1479 3 -576 1622 1483 668 3 -1671 1097 1516 1054 3 -63 267 774 306 3 -957 920 488 77 3 -1415 388 1140 1651 3 -28 1807 520 560 3 -1577 443 1304 492 3 -149 640 739 70 3 -661 1397 290 1083 3 -343 1095 724 1069 3 -967 870 895 758 3 -494 1522 582 1778 3 -1697 1640 1944 730 3 -1391 1433 71 452 3 -463 1708 1815 178 3 -135 327 116 1920 3 -784 1637 673 448 3 -1528 1474 1544 525 3 -1086 455 1683 898 3 -267 299 564 233 3 -1937 1604 626 505 3 -1222 1075 990 1340 3 -278 1000 520 128 3 -1563 1021 890 1007 3 -1724 1498 1039 460 3 -1036 677 118 619 3 -826 336 620 1641 3 -650 597 1494 461 3 -805 1307 1857 694 3 -1273 1454 1590 1303 3 -253 646 978 542 3 -55 511 475 1256 3 -216 922 1940 1459 3 -801 1280 1274 1500 3 -554 1923 1795 1737 3 -1677 1009 588 1612 3 -557 1082 1150 283 3 -287 649 140 542 3 -1530 1490 776 366 3 -617 262 634 1293 3 -510 789 692 915 3 -1575 987 1421 1405 3 -632 955 1831 84 3 -967 870 381 895 3 -1831 1674 1385 599 3 -99 66 98 658 3 -376 972 792 799 3 -1071 595 1638 250 3 -536 1418 1230 732 3 -886 1436 479 1723 3 -279 212 1012 721 3 -271 308 663 239 3 -523 1568 1026 496 3 -941 1412 648 1766 3 -617 262 11 634 3 -760 450 419 808 3 -68 1258 991 1456 3 -1025 1069 1333 1889 3 -1413 1102 1901 1405 3 -1883 1332 876 23 3 -911 1196 1483 1082 3 -457 894 1450 549 3 -259 439 773 228 3 -1147 827 1285 1657 3 -1338 1035 1314 573 3 -523 553 1893 1702 3 -1457 1688 595 1811 3 -1413 1102 1405 1926 3 -559 88 646 55 3 -1238 1569 987 462 3 -684 680 145 95 3 -760 563 450 808 3 -1932 1764 1140 505 3 -1718 1622 1384 514 3 -1711 1887 1501 1420 3 -430 493 1015 206 3 -1001 1300 973 924 3 -1932 615 1651 336 3 -1071 1457 595 1811 3 -1643 1243 936 1117 3 -1002 985 1257 591 3 -1803 1426 768 1582 3 -207 302 1188 1296 3 -1639 1030 1810 1433 3 -1101 1639 1155 952 3 -982 1101 1683 952 3 -928 1598 1610 748 3 -788 976 431 1392 3 -291 670 292 202 3 -535 718 732 536 3 -553 496 523 1026 3 -894 1197 1888 1761 3 -331 122 539 699 3 -1012 284 822 726 3 -1928 1536 1378 938 3 -626 1320 942 1592 3 -163 172 702 73 3 -180 207 80 1705 3 -252 706 1348 72 3 -591 487 1008 1370 3 -822 284 611 726 3 -1065 198 262 689 3 -1392 431 788 796 3 -789 1392 920 1514 3 -520 413 1092 678 3 -374 1264 1269 712 3 -234 291 202 711 3 -733 169 332 168 3 -1664 1628 782 1546 3 -818 1206 652 509 3 -531 543 1339 917 3 -734 851 223 579 3 -207 80 1188 302 3 -1044 59 1351 1030 3 -1412 1661 1481 625 3 -407 364 616 408 3 -1024 776 652 1107 3 -1676 120 337 1304 3 -1856 1411 1817 260 3 -943 1270 867 1192 3 -1113 1143 1298 1042 3 -193 191 725 192 3 -399 131 1387 1567 3 -531 917 417 1462 3 -1136 1432 787 1620 3 -63 229 564 267 3 -56 1081 1607 1137 3 -252 729 706 72 3 -459 1692 1887 432 3 -1139 671 974 828 3 -536 1029 732 535 3 -971 1114 332 733 3 -413 926 1092 678 3 -1940 1903 435 216 3 -1004 591 1478 1254 3 -1714 517 540 1882 3 -985 1488 1720 1824 3 -1281 786 1110 1153 3 -661 553 1893 865 3 -692 789 757 1126 3 -195 1044 1276 1030 3 -1362 965 696 555 3 -893 938 22 949 3 -1339 917 1094 417 3 -98 133 504 66 3 -1562 406 18 1486 3 -286 741 287 199 3 -497 505 495 626 3 -799 972 792 484 3 -153 743 699 1146 3 -1437 906 956 1236 3 -215 1755 307 1280 3 -351 159 1819 252 3 -1118 1866 1016 1162 3 -37 1277 750 563 3 -454 1359 1305 310 3 -882 1089 1452 601 3 -1086 455 898 1276 3 -642 1705 80 1188 3 -1159 570 1821 778 3 -223 1074 1229 851 3 -1805 1435 1707 1244 3 -921 581 1281 716 3 -1118 1162 1016 1569 3 -1324 1086 1124 855 3 -627 38 1317 88 3 -885 1066 1802 208 3 -1772 569 1063 1927 3 -703 1953 1164 598 3 -1620 1432 942 1126 3 -15 185 805 807 3 -1932 453 423 336 3 -991 779 662 612 3 -906 845 1464 1730 3 -1386 68 1949 353 3 -1587 197 1401 1596 3 -634 96 527 617 3 -26 771 155 109 3 -1874 13 228 300 3 -1402 1931 136 1616 3 -1544 1090 1780 1933 3 -705 1143 1684 452 3 -1883 354 585 1847 3 -1584 1650 928 42 3 -1020 1643 569 1670 3 -1134 924 973 803 3 -1705 180 753 642 3 -534 472 1508 1537 3 -71 1957 59 1875 3 -1785 227 6 1271 3 -370 1782 446 369 3 -686 1758 1242 493 3 -230 646 55 511 3 -1060 894 1058 1338 3 -1461 366 782 1840 3 -1860 817 703 1759 3 -1105 1290 943 530 3 -668 1811 1457 910 3 -482 1003 1355 1438 3 -102 482 1460 1292 3 -106 41 856 286 3 -1429 189 218 7 3 -1650 887 1741 1439 3 -504 679 1197 416 3 -136 1931 104 1616 3 -1655 1503 335 1348 3 -1216 534 1550 1599 3 -1132 1017 1950 916 3 -1247 1462 804 190 3 -578 531 1339 166 3 -1694 909 956 1212 3 -735 1242 791 686 3 -427 1019 1393 782 3 -571 959 1847 1728 3 -316 1013 1305 1359 3 -1109 14 1649 776 3 -1912 545 1373 802 3 -706 116 737 729 3 -974 1887 1711 1420 3 -826 1641 620 186 3 -1398 1579 603 1681 3 -207 302 1296 224 3 -402 598 138 1077 3 -508 67 1321 1163 3 -880 1818 221 1509 3 -1679 247 145 434 3 -868 1273 1272 727 3 -1518 838 73 529 3 -441 698 807 453 3 -1013 695 1925 1467 3 -1299 861 531 576 3 -1785 665 1271 923 3 -1222 1634 1340 1924 3 -1214 1848 770 908 3 -146 26 1689 1120 3 -1796 393 1011 429 3 -311 81 860 274 3 -391 1158 426 1246 3 -601 1482 1515 610 3 -1143 1113 705 1684 3 -1101 1574 952 1155 3 -1840 1164 1953 601 3 -926 1092 678 941 3 -174 1156 79 1056 3 -550 1743 974 912 3 -402 598 1077 438 3 -782 1628 1744 1546 3 -203 933 763 1340 3 -1619 1720 1042 1700 3 -235 202 254 1064 3 -1580 381 841 1101 3 -45 1223 827 1276 3 -1408 797 270 961 3 -992 1547 610 937 3 -234 711 268 997 3 -1548 1882 855 1028 3 -1672 1605 683 1507 3 -1487 379 1941 1211 3 -1572 1220 651 975 3 -1302 269 911 236 3 -543 191 544 744 3 -166 190 1462 417 3 -1273 1454 1303 1842 3 -713 541 825 44 3 -376 972 799 1111 3 -1220 269 911 1302 3 -790 46 1149 1084 3 -1633 1168 11 1342 3 -587 781 1881 1069 3 -937 1626 1746 1552 3 -1654 486 514 1150 3 -519 1480 878 246 3 -593 186 861 708 3 -1738 1388 1913 1053 3 -1900 491 119 1560 3 -66 691 1593 141 3 -27 188 852 1311 3 -60 843 521 330 3 -1900 1667 1560 533 3 -1214 1222 1447 770 3 -1477 1282 1556 1610 3 -308 31 997 1572 3 -646 511 978 542 3 -147 1403 1051 1479 3 -229 299 564 267 3 -822 726 611 604 3 -971 733 950 852 3 -503 1200 132 661 3 -1311 1157 552 732 3 -574 180 642 753 3 -465 392 1269 391 3 -853 863 946 1423 3 -1839 1752 770 908 3 -1226 565 1431 1843 3 -1525 1582 1803 1469 3 -874 1523 1482 689 3 -1135 929 1017 383 3 -1214 1924 1848 1166 3 -1857 1307 1764 694 3 -653 1226 784 1930 3 -109 1067 155 218 3 -593 708 861 20 3 -755 894 1450 457 3 -1040 1291 487 1370 3 -1560 1881 724 53 3 -759 1069 1826 1095 3 -548 1178 1154 556 3 -164 183 868 48 3 -639 1226 876 784 3 -1008 541 44 648 3 -140 926 646 542 3 -1178 1322 556 427 3 -226 1785 301 6 3 -1357 1607 981 471 3 -111 1219 1150 486 3 -1450 755 1013 416 3 -739 700 70 889 3 -1929 960 47 251 3 -823 1347 715 772 3 -1634 1222 272 1924 3 -789 1607 1876 1279 3 -111 1219 40 1150 3 -903 1586 586 1631 3 -309 681 880 242 3 -1848 913 1839 1081 3 -1527 832 907 529 3 -1136 510 1502 1512 3 -1041 936 572 1169 3 -735 1758 1242 686 3 -1530 1350 888 986 3 -832 1527 1248 529 3 -1147 962 827 1657 3 -320 1304 1001 492 3 -1019 636 905 538 3 -268 1064 235 997 3 -1575 793 602 1768 3 -548 858 1251 427 3 -758 1182 723 909 3 -630 125 855 1112 3 -1732 1154 1736 1803 3 -1515 601 1636 1438 3 -1747 986 1173 338 3 -1383 736 1301 1198 3 -531 417 1339 166 3 -699 749 1267 539 3 -1166 274 458 860 3 -925 349 176 182 3 -1027 1598 1913 748 3 -457 894 1338 755 3 -1153 1125 1326 697 3 -691 1091 62 939 3 -24 1821 1404 1159 3 -661 553 1563 1200 3 -436 1054 1671 1478 3 -265 685 230 541 3 -1368 803 1582 924 3 -903 831 356 175 3 -293 1924 933 1634 3 -1560 791 724 907 3 -1627 1064 704 512 3 -570 652 1206 371 3 -337 1300 121 973 3 -1917 1584 1190 42 3 -58 757 895 1155 3 -20 910 303 220 3 -1187 1498 932 1541 3 -606 1084 156 172 3 -1333 984 953 1025 3 -376 1849 103 1003 3 -904 1550 1727 378 3 -643 1534 1374 335 3 -1262 986 1452 1449 3 -1069 53 1333 1095 3 -970 12 1645 1315 3 -1784 610 1626 604 3 -1842 48 1454 297 3 -1054 1666 1503 1478 3 -210 1273 1454 1590 3 -1317 88 926 559 3 -926 38 140 88 3 -5 1762 1890 850 3 -266 1256 1360 1827 3 -148 1095 1621 686 3 -159 1221 715 1767 3 -724 53 1069 1095 3 -1315 12 1283 1695 3 -1796 636 1763 850 3 -513 103 142 609 3 -915 1427 692 1512 3 -1073 543 1339 999 3 -1315 12 1645 1283 3 -378 1040 487 904 3 -1766 669 1843 1370 3 -271 663 1303 239 3 -865 1893 1397 1781 3 -1356 1954 575 328 3 -771 596 1067 109 3 -523 1893 737 1568 3 -328 1954 575 1568 3 -865 256 890 687 3 -1232 936 1169 300 3 -1854 1039 1610 1282 3 -750 1738 1692 459 3 -975 797 1408 1286 3 -666 930 858 1024 3 -1246 1158 1077 285 3 -1809 1354 1502 457 3 -56 1602 1752 499 3 -1085 690 476 945 3 -1548 1124 597 33 3 -348 531 1339 578 3 -1448 674 1945 1507 3 -1684 1113 705 1475 3 -270 269 1220 237 3 -227 1065 1633 665 3 -630 1324 339 1112 3 -1573 656 788 1876 3 -476 945 746 553 3 -847 818 1349 479 3 -1265 1674 575 845 3 -726 284 611 1879 3 -1289 620 785 1240 3 -177 947 145 1329 3 -971 124 1812 834 3 -1633 1343 262 1065 3 -862 213 809 960 3 -1530 14 776 1490 3 -411 1211 154 105 3 -1443 403 1472 864 3 -789 1279 1392 728 3 -134 29 108 697 3 -1367 1748 1322 1897 3 -1194 187 871 809 3 -1136 915 1512 1176 3 -567 736 1149 1779 3 -428 1600 1828 1088 3 -1894 125 1410 1882 3 -605 912 1352 868 3 -614 841 1051 147 3 -888 872 1244 1552 3 -1111 1901 972 484 3 -169 187 47 1869 3 -869 143 514 208 3 -1768 810 1688 919 3 -1095 53 1333 1323 3 -798 1315 970 930 3 -1768 810 1495 1688 3 -1927 569 19 1000 3 -735 791 724 1095 3 -943 566 1446 1595 3 -985 904 1002 1824 3 -1303 1590 660 663 3 -1826 1333 1621 1095 3 -957 841 920 614 3 -835 730 16 631 3 -1474 16 525 1629 3 -661 201 1563 865 3 -53 1069 953 587 3 -1147 962 1657 444 3 -340 1899 1049 1475 3 -504 691 133 1197 3 -230 199 978 685 3 -943 1128 1364 1290 3 -537 574 642 753 3 -649 829 140 542 3 -389 444 1344 340 3 -20 1797 303 910 3 -140 829 926 542 3 -930 1645 1750 1283 3 -499 896 365 1104 3 -137 112 258 508 3 -427 548 1178 1251 3 -1493 1440 1032 754 3 -1194 146 25 187 3 -200 245 1609 1063 3 -1132 916 1950 1360 3 -1757 1424 1828 428 3 -560 522 19 1609 3 -1589 1778 848 1855 3 -1625 1794 1445 1068 3 -1393 1625 1445 1068 3 -888 1435 1805 1244 3 -1060 1313 1502 1057 3 -1946 1728 571 969 3 -982 344 1683 1101 3 -15 1857 805 1613 3 -1253 1429 1169 263 3 -1824 1332 876 1883 3 -411 1861 1496 154 3 -1201 1551 1021 676 3 -383 832 1470 1248 3 -1803 443 1426 1582 3 -755 49 416 1816 3 -423 980 1087 1861 3 -523 1781 737 1893 3 -1388 590 1055 492 3 -1692 1027 1598 1913 3 -669 678 1132 1773 3 -661 1893 1397 865 3 -1620 1279 1126 728 3 -655 1747 1594 986 3 -1754 49 1627 512 3 -1005 194 1673 976 3 -1110 648 921 1370 3 -474 793 1575 1768 3 -982 506 1706 1351 3 -1288 1857 1306 1037 3 -1130 468 1414 1926 3 -1130 468 1822 1414 3 -744 725 1832 1080 3 -1446 1831 1106 530 3 -320 492 322 590 3 -1842 968 1409 1743 3 -323 859 1613 730 3 -1006 889 183 161 3 -950 1851 1516 1097 3 -916 1132 1017 1481 3 -552 1716 1418 732 3 -627 413 86 562 3 -1191 572 1138 1169 3 -1362 1270 1038 948 3 -1589 1778 1855 494 3 -1365 644 1376 1327 3 -769 1063 569 923 3 -804 1462 1247 1718 3 -1297 499 1517 1835 3 -37 1027 750 1277 3 -645 632 65 935 3 -1391 1059 452 1121 3 -1848 1839 908 1081 3 -627 88 559 89 3 -1873 179 767 1215 3 -241 1075 990 1222 3 -115 114 502 957 3 -927 745 1026 959 3 -322 1406 470 1001 3 -38 128 829 649 3 -1495 507 1768 1068 3 -856 716 1125 1281 3 -243 242 1167 309 3 -1776 851 734 579 3 -1575 1688 980 919 3 -1207 1194 472 1765 3 -234 202 268 711 3 -478 1411 1286 717 3 -1848 1839 770 908 3 -614 431 1051 1392 3 -880 681 814 242 3 -560 520 567 562 3 -330 1485 521 150 3 -1193 1055 492 1913 3 -1795 1923 566 1270 3 -968 1409 1910 1842 3 -1483 911 557 1571 3 -1611 953 1912 587 3 -1390 114 957 488 3 -857 681 1354 1321 3 -1188 1327 1376 642 3 -1695 1699 652 570 3 -253 88 55 646 3 -1600 1373 1368 1193 3 -641 1082 628 573 3 -744 191 544 725 3 -1231 631 1093 1308 3 -902 1043 522 1549 3 -654 878 1630 1011 3 -1602 499 56 1835 3 -1408 1489 1220 1623 3 -721 1316 1905 1138 3 -1392 614 796 920 3 -914 1589 1789 623 3 -10 1071 250 220 3 -997 1064 1473 1532 3 -1123 955 892 632 3 -521 1485 677 777 3 -619 677 118 966 3 -967 1466 870 723 3 -1299 1066 1802 1205 3 -1457 668 1646 812 3 -1790 1933 1786 1628 3 -278 1000 128 288 3 -868 48 1273 500 3 -997 573 651 641 3 -868 48 210 1273 3 -1022 87 1807 144 3 -1828 1600 1218 768 3 -1950 1135 1955 156 3 -55 230 1256 266 3 -1363 1569 987 1016 3 -763 1703 547 1906 3 -1421 1926 1076 1413 3 -1012 1 284 726 3 -887 1611 1656 1838 3 -988 317 1863 1263 3 -1795 1583 554 1524 3 -1715 935 1389 1668 3 -1596 197 1401 1221 3 -427 1463 501 1678 3 -1260 1770 899 1692 3 -1075 1634 1340 1222 3 -69 66 99 658 3 -1870 995 1248 702 3 -63 564 265 541 3 -1103 550 1740 1245 3 -301 1785 227 6 3 -37 1815 1027 178 3 -507 538 1393 1019 3 -806 1279 656 1137 3 -324 122 1942 331 3 -450 419 437 1395 3 -1020 1643 1742 485 3 -376 792 1460 1003 3 -1101 895 841 1155 3 -934 753 1337 607 3 -234 711 997 628 3 -198 689 1065 611 3 -1326 1281 1125 1153 3 -1601 184 153 749 3 -1496 1539 1087 1861 3 -1626 1319 1224 572 3 -602 1068 1184 1202 3 -42 1373 802 1294 3 -220 1071 250 361 3 -632 927 1595 1954 3 -1661 673 1129 676 3 -559 646 475 55 3 -936 219 1319 1169 3 -271 1303 1372 239 3 -1339 543 1094 917 3 -236 1571 557 911 3 -140 646 253 542 3 -1400 49 1013 755 3 -212 1 1012 721 3 -307 1079 752 21 3 -240 1791 293 1924 3 -328 327 135 1920 3 -174 1156 1612 1250 3 -67 1321 1163 363 3 -448 1766 1930 1366 3 -1264 712 374 792 3 -910 1811 1071 220 3 -554 1524 1583 1504 3 -1114 852 733 971 3 -1083 687 729 72 3 -606 52 1084 172 3 -863 944 554 1788 3 -1169 219 1319 263 3 -91 364 746 690 3 -1422 1333 1085 984 3 -854 1007 774 643 3 -529 1865 1242 493 3 -1348 687 1235 1534 3 -413 1000 786 829 3 -288 1326 32 134 3 -339 455 1683 1086 3 -972 1264 792 484 3 -723 1182 967 1466 3 -375 1013 49 480 3 -1636 1672 600 1722 3 -520 19 1092 786 3 -1391 71 1121 452 3 -577 692 981 1387 3 -65 945 690 984 3 -610 882 874 888 3 -1241 942 881 1172 3 -468 1102 1111 1413 3 -967 723 870 758 3 -401 400 1402 473 3 -531 620 1289 1240 3 -420 1941 379 558 3 -97 371 847 96 3 -1172 942 881 820 3 -1690 1361 1938 435 3 -1395 419 437 828 3 -595 104 1638 250 3 -1402 400 1931 473 3 -390 1697 1535 1099 3 -880 681 806 814 3 -28 1609 560 520 3 -793 1184 600 1421 3 -1047 1301 1181 521 3 -104 1638 810 595 3 -615 1564 505 540 3 -543 999 22 531 3 -540 999 22 543 3 -121 1406 973 315 3 -287 199 978 253 3 -612 662 1103 605 3 -526 880 1818 221 3 -1634 1075 272 1222 3 -1632 386 460 1947 3 -1889 65 984 1025 3 -1199 636 1046 1019 3 -579 851 223 1229 3 -1106 1062 1105 530 3 -583 1223 1023 1298 3 -115 114 957 1390 3 -413 38 829 926 3 -1786 1933 655 1628 3 -886 1549 9 1805 3 -559 678 1132 475 3 -1417 1957 452 1657 3 -532 971 546 638 3 -210 1372 528 1590 3 -905 1542 1768 810 3 -1765 1478 1868 382 3 -1524 554 764 800 3 -551 1750 414 1199 3 -564 685 541 581 3 -733 1114 332 169 3 -1288 742 1857 1330 3 -1061 1116 258 205 3 -999 543 1339 531 3 -90 1200 746 1591 3 -1614 1883 1660 1170 3 -1345 956 1121 385 3 -174 1156 1056 1440 3 -1425 900 58 1578 3 -1068 793 1484 1664 3 -90 503 1183 1200 3 -1071 1489 812 1646 3 -593 531 166 1299 3 -1211 379 558 1141 3 -229 1871 685 564 3 -786 1326 1000 1020 3 -1506 867 813 1128 3 -657 700 662 779 3 -624 975 1274 1519 3 -553 496 1026 945 3 -1637 673 1021 676 3 -495 1223 1276 819 3 -1572 269 1220 270 3 -665 1784 874 9 3 -1655 1666 335 1503 3 -397 746 1951 745 3 -1784 1785 604 1626 3 -383 929 1017 1189 3 -1591 503 1200 132 3 -75 418 244 310 3 -151 1383 1873 998 3 -81 272 1214 1924 3 -343 1885 1416 724 3 -290 1397 1893 135 3 -1898 1449 1599 1455 3 -106 856 716 1125 3 -1878 368 1653 1659 3 -1549 560 1721 954 3 -662 753 537 795 3 -718 830 1253 536 3 -1492 986 1606 1594 3 -692 981 789 510 3 -1549 1043 560 954 3 -1176 1662 1241 1407 3 -1775 1515 1547 1455 3 -213 1862 1453 809 3 -633 667 1139 684 3 -1562 1625 1585 1445 3 -51 1388 1913 1738 3 -1538 1477 760 1853 3 -1548 125 855 1882 3 -685 286 199 741 3 -326 388 1140 1415 3 -759 1826 1621 1095 3 -1503 1671 1471 1054 3 -1207 761 1194 1689 3 -501 1897 1562 783 3 -1631 515 839 1376 3 -1612 1440 1009 1156 3 -757 692 58 900 3 -408 364 91 690 3 -518 796 77 1876 3 -1127 814 276 242 3 -1556 776 1109 1649 3 -873 1015 206 264 3 -652 1699 703 402 3 -1291 1370 921 487 3 -458 1888 1925 860 3 -258 112 67 508 3 -1245 1381 1154 556 3 -864 403 1105 1106 3 -641 651 1220 812 3 -851 1074 362 223 3 -1437 76 1956 1694 3 -1103 795 1177 946 3 -1215 1361 765 954 3 -825 1686 713 305 3 -1568 1892 1855 1730 3 -1299 1066 20 1797 3 -120 1934 1300 1304 3 -661 553 865 1563 3 -1216 683 1672 1701 3 -1872 1130 1430 1076 3 -1085 673 1422 784 3 -345 1350 1234 1576 3 -1151 39 800 1423 3 -1683 898 952 1086 3 -1274 1939 752 1280 3 -924 1368 1419 1426 3 -1278 788 209 1573 3 -786 1153 1326 1020 3 -858 666 551 930 3 -753 700 739 934 3 -287 741 1125 542 3 -490 1917 42 1863 3 -1220 1489 812 1623 3 -740 1010 1191 816 3 -1350 1109 1576 887 3 -182 515 642 839 3 -683 835 1093 1430 3 -383 529 832 1248 3 -1349 818 1690 824 3 -703 817 598 438 3 -620 1087 1801 785 3 -1455 1515 1547 1452 3 -526 880 221 309 3 -336 1087 1932 615 3 -1242 635 1323 686 3 -580 194 1266 1479 3 -898 1044 469 1030 3 -294 981 933 1203 3 -243 273 1167 242 3 -1403 1479 1266 976 3 -1479 194 976 1673 3 -1403 1479 976 1051 3 -489 1236 956 906 3 -1468 5 1283 1729 3 -760 1477 672 1853 3 -1314 1491 641 1196 3 -1230 1429 1169 1253 3 -1888 295 244 205 3 -1169 1429 1018 263 3 -230 1686 511 1256 3 -1711 1420 353 974 3 -1813 1734 1174 1608 3 -436 1727 904 1671 3 -480 658 98 504 3 -1889 645 1312 65 3 -1528 618 1484 1184 3 -1512 1427 692 1511 3 -1564 1378 1289 602 3 -1140 1330 1764 1932 3 -971 733 638 950 3 -1010 341 1191 1418 3 -973 387 1820 315 3 -1432 949 938 787 3 -732 1429 1716 1230 3 -760 419 963 367 3 -711 1219 670 1035 3 -803 863 800 946 3 -1251 551 633 414 3 -113 1850 526 67 3 -763 1340 1906 257 3 -153 184 718 535 3 -924 803 946 1733 3 -812 1483 1571 1196 3 -588 1760 1364 903 3 -914 582 1382 1589 3 -903 1760 1364 356 3 -809 1851 1516 871 3 -1813 1681 603 1445 3 -334 1272 161 516 3 -1436 897 664 479 3 -1648 1418 341 1010 3 -721 1319 279 1935 3 -914 582 1143 1382 3 -604 992 610 1626 3 -196 1160 461 1005 3 -1385 1674 575 1265 3 -32 649 287 542 3 -457 1239 1835 1809 3 -942 1176 1241 1126 3 -1635 1470 383 653 3 -1710 1795 1170 948 3 -1171 214 170 1880 3 -1645 464 1796 5 3 -487 1829 1918 1478 3 -236 911 557 283 3 -1791 656 1876 1607 3 -1423 863 800 1777 3 -981 1145 1886 577 3 -1637 673 676 1085 3 -1773 678 1132 1753 3 -905 1616 1542 810 3 -1225 864 347 1394 3 -963 1395 419 760 3 -1447 241 1214 311 3 -502 1357 131 1203 3 -1029 536 1010 751 3 -939 1058 894 842 3 -477 1481 669 1766 3 -77 1876 502 293 3 -414 636 1046 1199 3 -602 793 1184 1068 3 -595 424 154 361 3 -153 184 535 749 3 -327 384 1730 906 3 -1042 532 1113 1382 3 -640 889 1006 334 3 -147 1580 841 1574 3 -805 694 1926 1076 3 -1022 1807 1171 144 3 -1123 84 955 632 3 -1102 4 1901 1118 3 -1200 746 132 1702 3 -372 1206 524 97 3 -468 1102 1926 8 3 -1608 1710 483 764 3 -1713 1424 1757 338 3 -947 1859 1679 434 3 -115 957 77 614 3 -1645 1763 1283 5 3 -1043 261 214 298 3 -1333 690 635 1085 3 -821 425 92 1472 3 -351 1221 1596 159 3 -902 217 1459 277 3 -1198 52 736 171 3 -500 1409 1842 801 3 -744 191 725 193 3 -334 66 658 1593 3 -715 1789 1684 1401 3 -294 1145 1284 933 3 -117 116 706 729 3 -1631 176 925 1733 3 -32 29 134 697 3 -420 850 1911 1941 3 -18 1491 641 1314 3 -1283 1860 1505 1763 3 -1615 1440 1009 1677 3 -1026 1735 523 1050 3 -418 75 244 295 3 -117 729 706 252 3 -387 447 1820 315 3 -388 1140 1651 1932 3 -406 1217 18 1486 3 -1396 102 498 482 3 -287 199 741 978 3 -64 1098 1388 1249 3 -1308 1298 1161 16 3 -955 1674 466 1954 3 -1273 500 48 1842 3 -821 403 425 1472 3 -626 1592 942 1604 3 -301 822 1343 1065 3 -903 356 1506 794 3 -1528 1629 525 618 3 -15 747 807 1857 3 -119 1526 1900 907 3 -107 106 1465 716 3 -520 1609 19 1927 3 -807 747 1330 1857 3 -1216 1142 683 1943 3 -588 1134 973 944 3 -1701 1700 1550 1216 3 -1163 707 880 681 3 -1110 669 1092 941 3 -324 451 331 1430 3 -79 935 645 1389 3 -1950 1237 156 222 3 -1257 985 1002 585 3 -63 265 305 1686 3 -1193 1249 1913 748 3 -552 1157 1716 732 3 -1567 981 577 1145 3 -937 610 1552 1547 3 -1011 636 1796 473 3 -971 1114 722 332 3 -1721 1805 1707 19 3 -284 611 1228 198 3 -340 1344 1812 1475 3 -948 1270 1038 1213 3 -1555 689 611 1523 3 -485 1557 1232 1643 3 -1002 904 985 591 3 -1559 1427 1407 1660 3 -662 574 537 753 3 -1263 802 754 781 3 -1167 242 681 309 3 -1062 403 1105 425 3 -1443 1886 1472 547 3 -939 508 589 137 3 -764 1524 800 483 3 -143 885 514 208 3 -1910 1280 1842 801 3 -1114 852 971 722 3 -971 722 124 834 3 -882 601 1452 610 3 -849 734 85 1310 3 -1094 191 417 917 3 -415 1103 1740 1245 3 -1406 387 470 973 3 -1060 1058 1384 1338 3 -1539 1087 1641 1496 3 -294 981 1145 933 3 -493 73 929 1195 3 -478 624 783 1623 3 -902 217 1043 298 3 -1654 1622 1210 1483 3 -967 1466 380 870 3 -1002 591 1257 1366 3 -350 636 866 1763 3 -1817 1616 473 1402 3 -1628 655 1594 1461 3 -1034 458 363 1061 3 -770 1340 1447 696 3 -1130 1822 421 1945 3 -1394 1192 647 1446 3 -1154 1803 768 1469 3 -490 1863 802 754 3 -213 107 1453 1862 3 -1727 378 436 904 3 -874 1482 601 610 3 -651 975 1220 1623 3 -118 777 677 1485 3 -1227 362 734 851 3 -677 1904 521 1181 3 -839 175 1631 1586 3 -1411 815 1817 717 3 -1448 1605 1507 1945 3 -1001 1406 470 973 3 -580 1574 1479 1403 3 -1247 190 804 143 3 -1320 1474 881 1592 3 -517 505 977 1714 3 -167 1240 531 593 3 -1650 1658 1556 1109 3 -949 1604 938 1928 3 -1509 880 1278 312 3 -934 640 889 739 3 -191 43 725 192 3 -878 1367 1630 478 3 -478 624 1623 1286 3 -1939 308 1274 238 3 -1122 1120 1067 1179 3 -1563 201 1007 865 3 -463 460 1708 1632 3 -1216 1701 1712 683 3 -838 1195 493 206 3 -591 487 1370 989 3 -510 1512 1511 1362 3 -874 1723 886 1458 3 -521 1485 777 150 3 -903 831 315 356 3 -1020 1643 1670 1742 3 -890 865 687 1781 3 -1187 1096 1690 1938 3 -726 1879 611 482 3 -832 533 1248 1527 3 -1090 1332 1780 23 3 -1336 378 436 1097 3 -1194 761 901 1122 3 -414 394 1529 654 3 -1486 1748 556 1245 3 -1065 689 604 611 3 -1067 1120 155 1179 3 -1710 1517 1297 1777 3 -226 1785 6 259 3 -1422 1333 635 1085 3 -699 331 422 539 3 -1545 100 254 512 3 -520 1609 1927 278 3 -60 171 151 1844 3 -1619 1700 846 1727 3 -465 884 1269 1309 3 -518 796 1876 1573 3 -1112 1369 1548 196 3 -1192 1105 943 1446 3 -836 1072 463 360 3 -293 933 1203 203 3 -359 1724 355 1498 3 -1810 1030 59 1433 3 -174 1250 1612 442 3 -1553 833 1273 660 3 -1360 475 916 1256 3 -1151 39 1423 795 3 -272 1075 241 1222 3 -1143 1033 1433 1417 3 -818 1490 14 509 3 -1 1879 498 284 3 -1323 1865 1470 1422 3 -1289 615 1564 1801 3 -884 426 1759 438 3 -1787 1025 984 65 3 -969 58 571 1578 3 -324 323 859 1613 3 -15 807 805 1857 3 -1070 1218 1734 1828 3 -1390 900 1425 1387 3 -577 1886 837 647 3 -1589 772 1855 693 3 -1845 1367 1859 1748 3 -348 1073 1094 1339 3 -1112 891 196 1324 3 -1235 1254 1745 643 3 -536 1191 1230 1418 3 -1419 1001 973 924 3 -480 1013 49 504 3 -430 493 635 1015 3 -1899 1401 1475 638 3 -57 110 589 127 3 -695 1359 555 1756 3 -1850 57 940 508 3 -1232 1041 1169 936 3 -1478 382 1666 1131 3 -1838 1470 1669 1837 3 -1669 1470 1248 1837 3 -339 1086 1683 1324 3 -5 1763 1283 1505 3 -1043 217 261 298 3 -1494 855 33 626 3 -588 1364 944 903 3 -1202 1068 1794 1378 3 -1381 840 1709 1585 3 -1082 40 1219 1150 3 -718 152 732 7 3 -1832 461 1028 1902 3 -1268 1606 428 395 3 -235 1064 1473 997 3 -644 1776 1365 851 3 -1487 1911 1108 1941 3 -1082 40 1150 283 3 -473 1931 1616 558 3 -754 1863 802 1263 3 -16 532 1298 1712 3 -1686 541 511 825 3 -1711 1177 443 1525 3 -1493 470 1677 1615 3 -616 759 1621 148 3 -548 858 427 1209 3 -1306 1037 1474 1023 3 -577 1886 981 1511 3 -1502 1313 1137 1136 3 -1657 962 446 444 3 -1473 1532 704 663 3 -1509 1278 61 312 3 -1615 1440 754 1009 3 -1514 488 920 789 3 -1533 1510 362 1227 3 -421 1822 405 1945 3 -229 199 265 685 3 -1387 1567 131 1357 3 -981 1145 1703 1886 3 -1920 1892 116 737 3 -1451 877 1167 273 3 -1662 1174 1597 1698 3 -273 877 1166 1451 3 -43 190 417 917 3 -1610 1282 1556 1854 3 -495 626 1565 497 3 -249 454 1305 310 3 -1185 1660 1559 1522 3 -64 1388 1055 1249 3 -241 990 275 1447 3 -45 1044 455 1276 3 -495 626 1320 1565 3 -942 1432 1176 1126 3 -324 1613 1663 835 3 -348 1339 1094 578 3 -1491 651 812 1623 3 -259 923 314 439 3 -914 1782 452 1121 3 -1240 785 861 186 3 -1389 701 1504 1364 3 -110 842 589 1091 3 -733 332 834 168 3 -1458 1164 882 601 3 -114 488 1390 1387 3 -398 1394 637 347 3 -1458 601 874 1523 3 -1367 1480 752 878 3 -544 543 893 1375 3 -140 38 926 829 3 -358 60 1036 983 3 -1268 1606 1603 1594 3 -1195 929 206 873 3 -110 1219 940 842 3 -1725 359 1541 682 3 -910 708 220 20 3 -1048 1390 115 841 3 -109 1520 218 13 3 -13 1520 218 300 3 -1722 1636 1744 600 3 -89 559 222 55 3 -732 152 1429 7 3 -301 1343 227 1065 3 -266 305 1256 225 3 -113 526 221 67 3 -1388 492 1913 1053 3 -63 267 541 774 3 -495 1037 1320 626 3 -1156 645 781 1833 3 -1403 841 1514 1155 3 -343 1095 1069 759 3 -385 1347 159 117 3 -952 1324 1403 1574 3 -952 1574 1683 1324 3 -1284 203 763 257 3 -1518 173 838 529 3 -109 1115 1520 13 3 -114 1357 488 1387 3 -1467 1756 695 311 3 -997 573 756 651 3 -151 170 1383 1198 3 -292 1545 691 141 3 -60 330 1844 151 3 -928 1854 1498 1039 3 -769 439 1117 1874 3 -248 90 1183 476 3 -1350 1424 428 1109 3 -1409 1910 1842 801 3 -1011 1796 429 473 3 -531 917 1339 417 3 -350 538 1546 866 3 -229 685 265 564 3 -1082 1219 711 1035 3 -1136 510 1137 1502 3 -617 1164 1458 1293 3 -1381 1469 39 1525 3 -314 439 769 773 3 -650 976 728 597 3 -1149 678 1955 559 3 -147 841 1051 1403 3 -649 288 829 32 3 -612 1352 779 662 3 -382 251 233 1647 3 -1923 1737 943 1270 3 -1659 798 1653 970 3 -12 1468 1283 1729 3 -1352 605 868 889 3 -1707 1244 1884 1670 3 -358 1527 162 163 3 -549 1313 1502 1060 3 -450 1395 437 459 3 -677 1667 1900 533 3 -182 925 642 515 3 -1433 1030 1957 827 3 -1808 931 201 1783 3 -1530 1089 986 1452 3 -382 960 1647 862 3 -163 529 162 1518 3 -30 1275 568 918 3 -87 46 562 144 3 -513 142 1379 751 3 -471 1839 696 770 3 -1091 589 127 939 3 -983 677 1900 533 3 -1808 931 1783 306 3 -1329 947 434 968 3 -1355 1292 1476 392 3 -833 1217 406 1486 3 -735 686 1095 148 3 -540 1882 1073 1028 3 -1566 57 137 589 3 -239 308 1939 238 3 -870 900 58 1425 3 -516 1272 528 1590 3 -90 397 746 364 3 -1871 856 741 581 3 -140 88 253 646 3 -151 330 998 1873 3 -1383 1047 1779 954 3 -1817 473 875 1402 3 -1936 963 667 367 3 -1829 1008 1370 648 3 -1029 674 751 1448 3 -1740 1273 868 727 3 -1436 1459 664 922 3 -94 1830 1792 1480 3 -920 77 614 796 3 -40 111 1150 869 3 -287 978 542 253 3 -220 1811 708 910 3 -1857 1764 1330 807 3 -949 1604 1928 540 3 -1064 573 1532 997 3 -1613 805 1663 835 3 -1235 890 1534 687 3 -1252 482 1905 816 3 -24 1315 1404 1821 3 -1833 1009 1521 587 3 -734 362 1533 223 3 -1552 1670 1805 621 3 -922 664 1940 1459 3 -462 987 423 1363 3 -119 1885 333 907 3 -1135 73 1237 304 3 -1278 880 1818 806 3 -1220 269 628 911 3 -1311 852 552 1157 3 -1075 203 1340 1634 3 -1434 644 1776 1365 3 -390 1099 1535 389 3 -1095 1333 1621 635 3 -1461 1840 782 1744 3 -911 1196 1082 641 3 -1898 1455 740 714 3 -1346 1679 1139 947 3 -964 360 1693 932 3 -1044 1351 469 1030 3 -1219 842 1091 1035 3 -1890 1762 1911 850 3 -663 1532 1217 756 3 -775 519 1411 1286 3 -930 1936 1659 798 3 -198 689 1555 1293 3 -1685 1754 1553 1642 3 -556 1562 1678 501 3 -1226 477 1930 653 3 -1207 716 1453 581 3 -801 1303 1274 1939 3 -45 1147 1640 1099 3 -1230 1418 1191 1716 3 -1025 645 1069 1889 3 -590 492 1419 1055 3 -491 1263 319 1560 3 -1293 617 598 138 3 -648 541 44 511 3 -475 941 511 926 3 -50 57 111 940 3 -764 1734 1524 483 3 -903 1364 944 1506 3 -903 1364 1506 356 3 -1544 1484 1090 1933 3 -554 1583 1795 1923 3 -185 8 1335 1238 3 -1347 956 1121 914 3 -1721 664 1549 954 3 -1446 1595 1831 530 3 -740 1455 1547 714 3 -1191 1418 341 1716 3 -111 57 110 940 3 -1485 355 777 1725 3 -990 257 85 849 3 -853 863 1423 644 3 -809 213 1558 960 3 -655 1484 1722 1744 3 -649 128 829 288 3 -1792 1830 1367 1480 3 -724 791 53 1095 3 -1354 1137 1081 56 3 -617 1723 11 262 3 -45 195 1276 827 3 -1918 1336 436 1097 3 -582 1522 1143 951 3 -715 1401 1049 1186 3 -882 1490 509 14 3 -103 102 482 1849 3 -17 1918 1336 487 3 -1953 1482 1158 1476 3 -1191 1169 1138 1230 3 -520 567 19 560 3 -1199 636 1750 414 3 -31 234 268 997 3 -1805 1444 1721 1234 3 -1599 1648 1508 341 3 -185 1238 807 698 3 -732 152 1179 1429 3 -1721 560 19 1823 3 -279 721 1012 1224 3 -597 1548 33 1494 3 -970 1315 1645 930 3 -102 498 1292 126 3 -823 772 715 623 3 -1041 714 740 937 3 -1177 853 946 537 3 -1147 1285 583 1535 3 -1008 487 1478 1829 3 -1049 1401 1475 1899 3 -1591 1200 746 132 3 -943 566 1192 1446 3 -1531 360 1039 1072 3 -249 98 75 1305 3 -264 231 1551 289 3 -578 1339 1094 166 3 -949 543 22 893 3 -1862 107 1689 146 3 -1493 844 1440 1677 3 -1341 1420 974 165 3 -1574 1101 841 1155 3 -911 812 1196 641 3 -1028 855 1494 626 3 -724 735 481 791 3 -567 1779 1540 1823 3 -1891 470 387 1677 3 -371 598 1206 847 3 -1194 1558 146 187 3 -753 934 739 607 3 -916 1412 825 1256 3 -568 1037 1306 1023 3 -1268 1757 428 1492 3 -1631 176 1733 1334 3 -1435 565 1234 1707 3 -201 865 1083 256 3 -274 273 1451 243 3 -1928 1031 1378 1536 3 -996 1864 282 1534 3 -1921 1202 1172 881 3 -1933 1090 1780 1786 3 -706 687 1235 1348 3 -1769 1249 1055 490 3 -469 982 1683 898 3 -615 1564 540 999 3 -711 670 1064 573 3 -677 1838 1181 1741 3 -1200 289 1563 661 3 -748 490 42 1193 3 -1341 165 974 177 3 -1846 1002 354 585 3 -1845 1859 1367 1792 3 -477 1481 1635 1773 3 -458 908 857 1848 3 -1671 1589 985 1004 3 -290 1568 328 135 3 -847 509 818 479 3 -862 960 809 382 3 -532 950 846 659 3 -1638 1442 1071 10 3 -1700 1090 1701 1332 3 -1406 387 973 315 3 -939 1566 296 137 3 -858 551 1251 1199 3 -1508 901 1793 1557 3 -1592 1604 820 942 3 -872 1898 1291 714 3 -1328 621 522 1063 3 -1584 777 1498 1658 3 -1518 702 529 73 3 -965 1776 734 555 3 -95 1679 145 684 3 -593 1299 166 20 3 -1842 1303 801 1939 3 -1300 1334 1733 584 3 -1820 1677 1612 447 3 -309 880 221 994 3 -939 1566 62 296 3 -810 1442 1071 1638 3 -1684 1401 1475 1049 3 -925 574 642 537 3 -131 1567 398 675 3 -1180 325 329 1894 3 -934 375 762 607 3 -1782 1684 452 705 3 -4 1569 594 1162 3 -1399 1241 33 1320 3 -763 1145 139 547 3 -475 511 941 1412 3 -1113 1308 546 532 3 -1572 997 756 651 3 -331 122 1942 539 3 -1254 1008 1478 1745 3 -511 741 1281 648 3 -1262 986 1449 1173 3 -1111 484 1413 1901 3 -124 346 122 1877 3 -308 31 1572 270 3 -781 1009 1833 587 3 -1273 1303 1590 660 3 -1660 1614 1488 1883 3 -876 1824 1173 1332 3 -166 1462 1299 531 3 -1506 1731 157 794 3 -890 931 1007 643 3 -1877 346 122 1942 3 -499 1104 365 1752 3 -1769 1055 754 490 3 -1541 682 932 1096 3 -237 1489 1408 280 3 -1127 1573 209 796 3 -1408 961 280 204 3 -237 1489 1220 1408 3 -1127 1573 518 276 3 -1408 797 961 204 3 -1449 986 1431 1173 3 -1803 1582 768 1469 3 -914 956 494 772 3 -1627 842 1091 679 3 -1398 1057 603 1579 3 -1403 1574 841 1155 3 -1034 1321 1354 549 3 -531 1031 576 861 3 -765 1576 1439 1047 3 -1204 84 1123 632 3 -1089 1164 1840 601 3 -906 1464 1694 1730 3 -647 1946 571 1578 3 -1028 461 1548 1902 3 -491 677 619 966 3 -1360 1827 304 1144 3 -1408 797 204 1286 3 -1324 580 891 196 3 -960 213 1647 862 3 -1140 505 517 615 3 -1064 1627 670 1545 3 -825 305 713 225 3 -1098 1632 51 748 3 -448 653 1661 673 3 -335 1771 282 233 3 -706 737 693 687 3 -706 737 687 729 3 -1856 519 878 1411 3 -791 832 53 1323 3 -1208 1508 1793 1898 3 -114 502 488 1357 3 -53 1333 953 1069 3 -722 1146 971 1877 3 -1572 641 997 651 3 -1711 974 550 671 3 -640 934 607 739 3 -71 1810 1696 1706 3 -805 1926 1872 1076 3 -1917 491 966 1584 3 -1720 1488 1780 1332 3 -1158 1293 598 138 3 -644 851 1586 1776 3 -1837 1248 1773 1635 3 -994 880 1509 312 3 -1325 723 58 969 3 -37 178 1027 1277 3 -1003 799 712 3 3 -1484 1722 1744 600 3 -1739 996 1534 72 3 -1542 507 538 1768 3 -838 73 529 493 3 -1860 1107 1283 703 3 -823 693 772 623 3 -507 812 1491 1495 3 -46 627 87 562 3 -91 90 476 746 3 -592 639 784 1422 3 -793 1484 1664 1546 3 -1626 992 610 937 3 -1915 231 1201 1551 3 -55 475 1360 1256 3 -528 1272 161 210 3 -399 1387 1390 1425 3 -491 1294 1667 1741 3 -867 1105 813 1128 3 -887 1741 1656 1650 3 -395 1678 427 548 3 -271 704 1590 663 3 -54 704 1590 271 3 -1281 1110 941 648 3 -1690 1938 1096 435 3 -1273 48 210 1454 3 -560 1807 520 562 3 -1286 797 204 246 3 -1150 111 486 514 3 -1772 1063 769 200 3 -90 1591 746 397 3 -53 639 1422 1470 3 -1210 1644 1625 373 3 -914 772 1589 623 3 -15 747 1857 742 3 -1064 1627 704 1532 3 -1139 1679 145 947 3 -1154 1736 550 671 3 -1391 909 1696 1810 3 -952 1155 1620 1126 3 -97 96 847 527 3 -712 1003 1355 1460 3 -681 1354 1313 1137 3 -427 548 1678 556 3 -471 913 1340 933 3 -1631 1586 586 644 3 -318 491 619 1917 3 -642 515 1376 839 3 -106 41 1465 856 3 -1592 1665 881 1202 3 -65 1595 943 530 3 -826 615 123 348 3 -789 1876 1392 1279 3 -569 1243 769 923 3 -602 1031 1378 1289 3 -923 1063 569 621 3 -1329 947 145 434 3 -1370 1766 1008 1366 3 -1829 1008 487 1370 3 -853 586 863 644 3 -1582 800 946 803 3 -1288 859 730 1613 3 -1598 731 1193 879 3 -739 149 70 180 3 -569 1243 923 621 3 -1189 1865 383 529 3 -1359 316 1434 1188 3 -538 793 1546 866 3 -606 1870 1428 736 3 -135 737 729 1397 3 -1570 1291 872 1208 3 -1564 1604 505 540 3 -591 1008 1478 1254 3 -1038 863 554 1788 3 -1020 485 1115 1643 3 -1695 570 1531 1821 3 -1224 726 1012 822 3 -312 1278 61 209 3 -880 814 806 1278 3 -131 1203 1567 675 3 -1315 12 1695 1821 3 -847 479 1349 527 3 -892 745 632 955 3 -105 104 595 250 3 -67 1163 526 309 3 -1748 1367 1859 1500 3 -1136 787 650 1620 3 -539 422 1507 1430 3 -1915 1551 625 264 3 -1598 1260 672 1692 3 -690 745 746 945 3 -1038 965 365 1776 3 -1268 1916 1463 395 3 -57 127 589 1566 3 -31 268 235 997 3 -1574 147 1479 1403 3 -387 1891 1677 844 3 -137 57 508 589 3 -1910 1500 1859 1280 3 -458 1888 860 205 3 -443 1419 731 1426 3 -1146 852 552 1311 3 -1825 959 1847 571 3 -490 1917 1098 1190 3 -900 870 58 757 3 -659 950 846 534 3 -249 207 454 310 3 -422 1601 699 749 3 -943 1364 1923 701 3 -991 1733 925 349 3 -609 513 352 142 3 -100 516 54 512 3 -1935 212 1253 263 3 -620 336 826 615 3 -1824 585 876 1002 3 -704 1064 254 512 3 -1016 1941 474 1211 3 -936 1319 1626 572 3 -1663 1335 451 1872 3 -1591 132 746 397 3 -1484 1090 1933 655 3 -354 585 876 1883 3 -117 1347 159 823 3 -1453 862 809 1765 3 -279 1117 259 219 3 -46 1149 156 89 3 -1238 1405 987 1569 3 -1528 1484 1665 1202 3 -916 1481 1017 625 3 -326 742 1330 388 3 -1187 1541 1096 179 3 -985 904 1671 591 3 -1720 1332 1090 1700 3 -1117 219 279 1319 3 -109 596 218 1520 3 -1180 125 630 339 3 -220 910 1646 1071 3 -1097 950 1671 1516 3 -1410 517 1882 1680 3 -822 611 1065 604 3 -810 1071 1542 1457 3 -1103 795 662 1177 3 -996 1655 1348 252 3 -430 1015 635 248 3 -418 1467 244 310 3 -959 496 1026 1568 3 -1593 658 762 480 3 -608 39 415 1709 3 -912 353 1259 164 3 -931 1534 643 890 3 -1733 863 946 853 3 -327 384 1892 1730 3 -814 1573 806 1278 3 -1214 81 1924 1166 3 -666 1024 672 1477 3 -1586 1788 644 1776 3 -63 265 1686 541 3 -531 1031 22 576 3 -523 1892 1855 1568 3 -567 1823 1540 19 3 -1359 1296 579 1756 3 -153 749 1267 699 3 -852 871 950 1867 3 -1711 1736 443 1501 3 -641 628 997 573 3 -360 359 1693 932 3 -1214 272 241 1222 3 -1399 819 33 952 3 -1564 1928 999 1289 3 -1082 1035 711 573 3 -497 626 33 855 3 -1300 1334 973 1733 3 -182 180 80 642 3 -1618 495 819 497 3 -291 1091 127 292 3 -442 447 1499 1612 3 -498 611 1228 284 3 -1382 1143 914 1684 3 -858 930 551 1199 3 -1898 1599 740 1455 3 -1449 1570 872 1208 3 -1676 337 1406 1001 3 -297 239 1372 1303 3 -1352 912 164 868 3 -583 1223 1298 1417 3 -237 269 1220 1302 3 -866 1358 712 1269 3 -1121 452 71 446 3 -1542 1616 717 1442 3 -1167 814 681 242 3 -1220 1302 911 1489 3 -546 971 1812 1899 3 -1317 38 926 88 3 -642 180 80 1705 3 -382 1868 862 1131 3 -1114 27 722 332 3 -715 914 1684 1789 3 -1437 76 1694 906 3 -827 1223 1417 1433 3 -240 276 293 1791 3 -400 379 1141 558 3 -1171 1880 170 1383 3 -815 1322 1019 783 3 -1375 738 629 36 3 -138 96 634 617 3 -90 503 1200 1591 3 -754 1032 1263 781 3 -1564 1604 1928 1378 3 -1293 689 262 198 3 -1432 1172 1176 1579 3 -103 1849 482 1003 3 -1615 470 1677 1134 3 -89 1950 156 222 3 -1004 1589 985 848 3 -767 179 1361 1215 3 -114 957 488 502 3 -207 1296 310 224 3 -173 529 1242 838 3 -149 207 454 249 3 -921 1281 648 1110 3 -1029 1418 732 552 3 -539 1877 659 1146 3 -365 1517 1362 1038 3 -848 1589 582 1778 3 -1435 1350 1234 565 3 -1005 193 1691 61 3 -1336 378 487 436 3 -150 179 767 1873 3 -1424 1600 1650 1373 3 -762 1642 375 934 3 -240 1791 1924 877 3 -1562 1491 18 1625 3 -1602 1517 1362 365 3 -640 934 762 607 3 -1432 1172 942 1176 3 -1760 1715 1668 357 3 -765 767 1187 1361 3 -365 965 1362 555 3 -1085 945 476 553 3 -1017 916 625 1827 3 -474 538 866 793 3 -525 1629 683 618 3 -366 1107 1840 1089 3 -1830 21 752 1480 3 -1531 964 1039 360 3 -365 896 1434 1104 3 -685 741 511 648 3 -268 202 235 1064 3 -303 1797 208 557 3 -1058 508 1850 940 3 -1064 202 254 670 3 -348 615 517 999 3 -243 309 363 67 3 -106 286 856 1125 3 -60 1904 358 1798 3 -896 1423 1434 1337 3 -409 1624 1311 152 3 -1717 467 723 1441 3 -1210 373 1625 1314 3 -1717 467 1441 82 3 -605 934 795 608 3 -1218 1504 1524 1368 3 -1480 878 1792 129 3 -597 1155 728 1620 3 -620 1289 615 999 3 -1412 511 648 44 3 -1214 1166 1848 458 3 -1740 1273 727 415 3 -1425 58 723 1578 3 -414 1046 1011 1630 3 -1887 899 1736 1501 3 -1451 274 243 1116 3 -1028 543 893 544 3 -1355 1003 3 1438 3 -579 1296 275 1756 3 -1050 1235 1257 693 3 -579 1296 302 275 3 -1416 781 1069 724 3 -875 473 429 401 3 -1449 1599 1550 1208 3 -31 628 1572 269 3 -322 1676 1406 1001 3 -71 1437 1391 1236 3 -1934 1711 443 1501 3 -902 217 277 1836 3 -908 1809 1752 695 3 -1669 533 1667 1838 3 -322 1001 1419 492 3 -873 1915 625 264 3 -128 1000 829 288 3 -1322 1019 427 1630 3 -42 1373 1600 1193 3 -1810 909 1696 758 3 -275 1296 224 1756 3 -1401 1596 1471 1587 3 -130 29 697 106 3 -1752 1602 365 499 3 -1117 1874 228 300 3 -1165 634 262 1293 3 -1481 383 1635 1773 3 -1449 1435 1570 1431 3 -1559 915 1241 1407 3 -1523 601 874 1482 3 -1000 569 786 1020 3 -177 1139 145 947 3 -336 1087 1641 1539 3 -1139 684 145 1679 3 -467 1425 723 1441 3 -751 1252 1010 1448 3 -1071 1489 1646 10 3 -867 1105 1472 1652 3 -448 1930 784 1366 3 -1557 1041 1232 1746 3 -1089 1107 1840 1164 3 -971 1877 659 532 3 -1682 1834 1398 1681 3 -886 882 479 14 3 -740 1775 1010 816 3 -484 712 3 474 3 -31 628 997 1572 3 -1215 1383 954 1047 3 -443 1419 492 731 3 -595 1638 810 1071 3 -921 1153 1281 1110 3 -1458 617 479 509 3 -1716 1179 1537 596 3 -1146 409 1311 720 3 -1333 1889 984 1025 3 -994 880 312 242 3 -257 203 763 1340 3 -269 1220 628 1572 3 -1619 1042 532 846 3 -1028 855 626 1714 3 -1886 1472 1703 1175 3 -897 435 780 922 3 -931 1374 643 1534 3 -1904 533 983 1527 3 -965 1906 849 734 3 -600 1744 1546 3 3 -1307 1801 1184 1564 3 -1707 1823 1721 19 3 -1792 1367 1845 1630 3 -905 636 1046 473 3 -69 66 658 334 3 -1888 1013 504 416 3 -1187 1658 1854 1498 3 -1768 507 1495 1542 3 -1712 16 525 1474 3 -668 1688 1457 1811 3 -32 29 697 130 3 -523 1050 693 1781 3 -172 1870 1135 606 3 -1579 1172 1176 603 3 -839 176 1631 175 3 -120 1304 1300 337 3 -1924 1791 293 913 3 -111 958 514 143 3 -1928 1604 938 1378 3 -952 1126 1399 1639 3 -784 1002 354 1846 3 -243 309 1167 363 3 -1719 119 1036 491 3 -78 1183 1200 676 3 -1155 58 1126 1639 3 -248 503 78 1183 3 -1576 1109 1439 887 3 -1642 1593 1754 516 3 -895 1639 58 1155 3 -200 773 769 255 3 -1308 1231 1812 546 3 -1852 1105 1062 412 3 -1174 1790 1172 1597 3 -60 843 677 521 3 -305 265 230 1686 3 -196 433 461 1160 3 -1224 992 1626 572 3 -420 1941 1911 379 3 -726 1879 721 1 3 -938 1057 1432 787 3 -939 589 1566 137 3 -1227 1506 157 794 3 -579 1365 1229 302 3 -182 176 515 839 3 -1652 425 93 813 3 -1091 127 62 939 3 -1081 814 681 1167 3 -1393 1562 507 783 3 -107 26 1689 146 3 -965 1175 1362 1703 3 -1571 281 1646 1489 3 -1641 1087 186 709 3 -1342 922 897 11 3 -1205 1802 804 1066 3 -916 475 1412 1256 3 -1350 1530 1606 986 3 -791 529 832 1242 3 -1525 39 1103 946 3 -750 1692 672 1395 3 -725 1152 1800 1080 3 -27 188 169 871 3 -523 553 1702 496 3 -27 188 871 852 3 -454 1188 1359 1296 3 -1307 1564 1528 1937 3 -75 1305 418 310 3 -182 839 642 80 3 -399 114 1387 131 3 -934 700 662 753 3 -200 314 1063 769 3 -1001 443 1300 924 3 -1436 922 897 1342 3 -1035 1654 1314 1082 3 -1664 1484 1628 1546 3 -1565 495 819 1223 3 -1034 1925 908 458 3 -579 1229 223 302 3 -782 1261 1199 350 3 -1204 892 1312 632 3 -851 362 734 223 3 -862 299 213 1647 3 -1957 71 1433 452 3 -1338 1035 573 1627 3 -1618 1276 1086 819 3 -1287 613 1204 1617 3 -1138 572 1935 1169 3 -1322 1630 815 1019 3 -482 103 1003 513 3 -135 116 729 737 3 -1916 768 1678 1088 3 -750 1027 672 1692 3 -455 469 1683 898 3 -1809 1354 56 1502 3 -605 934 662 795 3 -287 253 542 140 3 -230 978 646 511 3 -1886 1192 864 1472 3 -1109 887 1650 1439 3 -1402 473 875 401 3 -741 199 685 978 3 -1396 498 1879 482 3 -1456 349 925 182 3 -1085 945 1637 1751 3 -495 568 1223 1023 3 -464 393 1796 429 3 -1204 892 408 1312 3 -1287 1204 1312 1617 3 -306 931 774 1806 3 -292 670 254 202 3 -195 59 1044 1030 3 -1153 1675 1020 1742 3 -1305 375 454 762 3 -1145 1443 547 1886 3 -294 1145 139 1284 3 -510 1607 471 981 3 -703 1164 652 598 3 -458 1925 908 860 3 -1934 443 1300 1304 3 -901 596 485 1557 3 -1144 225 1827 873 3 -278 1772 288 200 3 -755 1816 1685 49 3 -87 627 86 562 3 -903 1631 1334 831 3 -169 871 733 1114 3 -1500 1748 1897 1486 3 -1023 495 1565 1223 3 -546 638 971 1899 3 -125 1894 630 855 3 -235 308 997 663 3 -849 555 579 275 3 -577 900 1578 837 3 -1592 1604 626 1937 3 -235 997 1473 663 3 -4 1866 1118 1162 3 -1384 1622 1210 1654 3 -1035 842 1091 1627 3 -1817 815 1630 1046 3 -871 950 733 852 3 -1273 801 1303 660 3 -288 829 32 1326 3 -1751 1846 354 585 3 -84 955 1831 1674 3 -1484 525 1090 618 3 -60 330 521 1844 3 -1879 1316 721 1 3 -1187 1658 1439 1649 3 -234 711 628 1082 3 -1087 785 186 709 3 -524 1349 160 97 3 -958 1247 1497 36 3 -418 1013 1925 1467 3 -1551 289 676 78 3 -1364 357 1128 1731 3 -792 799 712 1003 3 -612 912 1949 779 3 -295 1197 133 296 3 -1506 867 1788 1227 3 -914 494 1143 582 3 -382 1666 1471 1054 3 -893 629 738 787 3 -934 753 662 795 3 -1436 664 886 479 3 -1172 1662 1176 603 3 -394 368 1653 1878 3 -687 256 1534 72 3 -1617 632 935 530 3 -1776 851 1586 1227 3 -985 582 1382 1619 3 -1013 695 1467 1359 3 -828 419 437 1133 3 -1884 1244 1570 1291 3 -630 125 1112 339 3 -329 1086 339 630 3 -1662 1597 881 1233 3 -22 938 738 1536 3 -268 1064 997 711 3 -1029 184 536 751 3 -1601 153 699 749 3 -843 1485 521 330 3 -1662 811 1176 603 3 -949 626 1604 540 3 -237 281 1489 280 3 -104 1948 810 1616 3 -196 1005 461 1266 3 -1589 494 582 1778 3 -592 876 1513 354 3 -615 1932 1564 1801 3 -1140 615 1651 1932 3 -529 1189 1865 493 3 -1768 507 1664 1068 3 -592 984 1422 784 3 -121 831 1334 584 3 -1732 899 1736 671 3 -812 1196 373 1483 3 -1898 1793 1291 1557 3 -667 419 680 367 3 -1400 1151 1337 608 3 -818 652 1490 509 3 -1152 192 1509 61 3 -1874 13 255 228 3 -26 1120 155 771 3 -1224 1785 1117 1626 3 -1138 1316 352 212 3 -5 1505 1283 1729 3 -942 1172 1241 1176 3 -1477 666 1024 930 3 -489 1730 1212 1892 3 -1957 452 1433 1417 3 -188 25 1179 189 3 -174 79 1156 1250 3 -1314 1196 1082 1483 3 -1364 357 1731 356 3 -1045 1330 1764 1140 3 -239 308 663 1939 3 -941 1281 926 786 3 -1281 786 941 1110 3 -271 235 663 308 3 -706 729 687 72 3 -710 1513 1070 1583 3 -531 417 166 1462 3 -1125 1281 716 1153 3 -1231 631 1942 1093 3 -1274 1519 1500 624 3 -918 1618 568 1276 3 -735 686 791 1095 3 -992 726 1905 721 3 -538 1664 782 1546 3 -1391 1059 1433 452 3 -1592 1474 1665 1528 3 -69 658 762 334 3 -1922 1682 1681 1709 3 -846 1943 659 1216 3 -1201 1661 625 676 3 -1265 76 845 1464 3 -1238 423 807 453 3 -1161 583 1298 1308 3 -993 610 1482 604 3 -600 484 3 793 3 -183 889 210 161 3 -1695 1531 1024 1477 3 -803 554 800 863 3 -63 229 265 564 3 -762 69 334 640 3 -774 541 44 1008 3 -534 852 950 1867 3 -1291 1110 921 1370 3 -1252 1379 513 979 3 -854 1366 1846 1257 3 -900 692 577 1387 3 -1645 636 1283 1763 3 -336 1087 423 1932 3 -282 211 251 1771 3 -296 1761 137 258 3 -525 16 683 1629 3 -234 40 711 1082 3 -1380 1025 1787 65 3 -679 1338 894 1816 3 -1894 977 497 1714 3 -103 1396 609 482 3 -1197 939 62 296 3 -1032 1009 781 754 3 -117 489 1347 823 3 -1024 858 1209 1261 3 -963 1395 828 419 3 -1201 1412 1661 448 3 -643 1235 1534 335 3 -1156 1009 1833 781 3 -711 291 202 670 3 -1147 1657 1285 444 3 -101 516 161 528 3 -1140 615 123 1651 3 -1229 1188 302 1365 3 -1463 1445 1393 501 3 -1921 1463 1790 1445 3 -1229 1188 1365 1376 3 -1040 1449 1208 1570 3 -1853 37 463 1815 3 -387 1677 1820 447 3 -652 371 402 598 3 -1139 680 145 684 3 -556 1322 501 427 3 -717 1623 1286 478 3 -1691 193 1152 61 3 -300 936 1169 219 3 -1781 890 1235 687 3 -1197 939 691 62 3 -881 1544 377 1814 3 -1690 435 1349 824 3 -1448 1252 1010 1672 3 -1351 1706 1030 59 3 -1438 1482 993 1515 3 -748 490 1193 1249 3 -619 118 386 966 3 -1392 1279 788 650 3 -536 830 352 1100 3 -847 96 617 527 3 -427 1463 1393 501 3 -950 733 638 1516 3 -949 543 893 1028 3 -751 536 1100 184 3 -1170 948 566 1427 3 -1479 194 1266 976 3 -1412 1256 511 825 3 -1610 1282 1039 1072 3 -739 700 889 934 3 -1276 819 1223 1030 3 -33 626 1320 942 3 -1367 624 1897 478 3 -300 1429 218 1018 3 -1588 144 790 170 3 -321 320 1304 1676 3 -728 1279 1392 650 3 -1200 476 746 553 3 -1010 536 1191 816 3 -499 1239 896 1104 3 -1370 1008 591 1366 3 -1014 1211 1363 411 3 -1140 505 977 517 3 -1523 1482 1476 1158 3 -35 191 1094 543 3 -320 1676 322 1001 3 -1232 1557 485 596 3 -1367 624 752 1280 3 -159 715 1596 1819 3 -1149 790 606 736 3 -1735 1050 1257 693 3 -531 917 1462 22 3 -1707 1773 565 345 3 -183 1352 868 889 3 -1537 1716 596 1508 3 -445 561 342 645 3 -870 900 1425 1390 3 -571 837 647 1578 3 -1478 436 487 591 3 -1625 1834 1681 1579 3 -912 165 353 164 3 -363 309 1167 1163 3 -1013 1400 1239 1104 3 -1523 1476 1555 1158 3 -886 1549 664 9 3 -1754 1627 704 512 3 -644 1631 1376 853 3 -1011 394 414 654 3 -1302 236 1571 281 3 -1711 1887 974 671 3 -1816 755 1398 1338 3 -1294 1741 42 1656 3 -1508 596 901 1557 3 -1834 1804 1377 1625 3 -781 645 1416 1069 3 -479 818 1349 824 3 -1442 1489 1623 812 3 -640 889 70 1006 3 -582 951 1042 1720 3 -1544 1484 1933 1665 3 -1278 814 1573 1127 3 -844 74 1440 174 3 -927 745 945 1026 3 -1520 1643 936 1117 3 -1235 1257 854 1050 3 -401 850 420 473 3 -1016 1211 1575 1363 3 -1405 694 1421 1926 3 -643 1745 1374 774 3 -1660 969 1728 1778 3 -602 1564 1202 1184 3 -1657 444 446 369 3 -1680 1073 35 348 3 -1435 872 1244 888 3 -1915 231 713 1201 3 -1873 179 1215 688 3 -826 186 620 167 3 -583 1223 1417 827 3 -704 1532 660 663 3 -1386 1949 1300 1934 3 -755 1239 1922 457 3 -911 1082 557 283 3 -1023 1037 1320 495 3 -1306 1528 1474 1037 3 -110 291 1219 1091 3 -610 1452 888 1552 3 -76 1717 1265 82 3 -1922 1239 1835 457 3 -659 532 1943 846 3 -1470 1226 639 1422 3 -1262 1452 986 1089 3 -679 1627 842 1338 3 -1310 990 85 849 3 -230 199 253 978 3 -883 1497 958 1247 3 -996 1348 1864 1534 3 -1612 1156 1389 1250 3 -762 658 99 480 3 -499 1297 896 1239 3 -1923 1504 1521 701 3 -260 519 1411 775 3 -1384 1536 1210 1622 3 -1449 986 1435 1431 3 -620 1289 999 531 3 -679 1627 1338 1816 3 -902 1459 664 1436 3 -870 1390 757 900 3 -811 1517 1512 1602 3 -694 1896 1764 423 3 -1182 1956 1717 723 3 -1425 900 1578 577 3 -943 1105 1192 867 3 -1814 1698 1780 1488 3 -758 723 870 58 3 -1374 335 282 233 3 -1716 1169 1191 1230 3 -1226 1843 1930 477 3 -993 482 1438 1252 3 -804 1802 1718 514 3 -149 69 640 70 3 -1366 44 1008 1254 3 -985 1824 1002 585 3 -747 807 1330 441 3 -23 1757 1698 1786 3 -413 520 786 1000 3 -942 949 820 1432 3 -1451 877 1166 1848 3 -1213 764 800 1777 3 -1036 491 119 1900 3 -1346 684 1845 633 3 -700 574 657 662 3 -600 1421 618 1413 3 -789 1126 1514 757 3 -1631 831 903 175 3 -465 374 1269 392 3 -1498 359 932 1541 3 -992 610 993 604 3 -422 1601 674 421 3 -1231 971 1812 546 3 -705 1657 452 1782 3 -1197 1888 504 416 3 -1071 1442 1542 812 3 -1311 1581 1157 152 3 -1766 477 1481 1412 3 -1449 1208 872 1898 3 -870 758 58 895 3 -929 625 1015 873 3 -557 911 1483 1082 3 -1863 491 1917 42 3 -1343 198 262 1065 3 -1937 1320 626 1592 3 -1937 1474 1320 1592 3 -383 1135 1132 1017 3 -1607 913 1357 1876 3 -628 711 997 573 3 -1864 211 282 1771 3 -341 1599 1010 740 3 -1579 1445 603 1681 3 -1920 1730 1892 1568 3 -1593 658 504 66 3 -383 929 1189 529 3 -1556 1598 1610 928 3 -1414 1413 799 1605 3 -1519 624 783 1897 3 -1749 521 777 150 3 -343 1416 1069 724 3 -329 1180 630 339 3 -1467 1359 1756 224 3 -1689 719 107 766 3 -1461 655 1594 986 3 -637 1225 1394 1052 3 -1436 277 922 1342 3 -397 745 1951 1123 3 -124 346 1877 1231 3 -1709 608 1922 1685 3 -1112 1369 196 891 3 -1550 904 1700 1332 3 -1284 1906 139 1919 3 -54 235 1473 271 3 -704 254 54 512 3 -235 254 54 1473 3 -1795 554 764 1524 3 -1615 1419 470 1134 3 -1247 190 143 883 3 -694 1421 1926 1076 3 -824 964 1187 14 3 -1584 1658 928 1650 3 -1805 1549 9 621 3 -1163 1321 707 681 3 -621 1549 522 19 3 -1320 942 881 1241 3 -271 235 1473 663 3 -1443 1394 1886 577 3 -920 614 1051 1392 3 -705 827 1285 583 3 -1936 760 963 367 3 -1484 1544 1090 525 3 -65 892 745 632 3 -725 192 1800 1152 3 -1525 924 1582 946 3 -477 1635 1481 653 3 -1687 866 3 712 3 -377 951 1474 1023 3 -964 1187 1690 824 3 -1491 812 641 1196 3 -486 958 36 514 3 -587 1009 1521 545 3 -1351 1706 982 1030 3 -1456 349 991 925 3 -1711 1501 1934 1420 3 -1278 1691 976 650 3 -1920 327 116 1892 3 -128 413 829 1000 3 -661 865 1083 201 3 -1918 1207 1765 1868 3 -1718 1462 22 1622 3 -1918 1765 1054 1478 3 -1735 1050 1846 1257 3 -1366 1002 1846 1257 3 -305 306 713 231 3 -713 63 541 774 3 -135 1920 737 1568 3 -1177 991 1300 1733 3 -713 63 774 306 3 -305 63 713 306 3 -1136 1176 811 1057 3 -548 1178 556 427 3 -1686 825 511 1256 3 -489 1694 1730 906 3 -1099 1640 1535 1147 3 -337 1258 121 1300 3 -1421 1307 1528 1629 3 -385 489 956 1347 3 -988 449 1263 1032 3 -337 1300 973 1001 3 -15 185 807 747 3 -49 1685 755 1400 3 -866 1687 1860 1763 3 -388 441 1932 336 3 -534 659 1648 1216 3 -1388 64 1055 590 3 -295 1197 296 1888 3 -1187 1938 1690 1361 3 -1036 843 118 677 3 -1168 689 874 1784 3 -1689 766 761 771 3 -74 1056 988 1032 3 -395 1088 1678 548 3 -61 1691 1278 1152 3 -1450 1354 457 549 3 -1058 508 1761 1321 3 -534 378 1097 1727 3 -824 1349 479 897 3 -1692 1260 672 899 3 -9 1549 1328 621 3 -957 77 488 502 3 -1773 1540 1707 669 3 -551 1936 1659 930 3 -1211 1141 1948 105 3 -1870 1428 995 606 3 -932 359 1693 682 3 -741 978 685 511 3 -1934 1501 622 1420 3 -975 238 270 797 3 -773 1874 255 228 3 -1189 1129 1015 625 3 -1503 1655 623 706 3 -1735 1855 693 848 3 -765 1187 1444 1361 3 -1692 1027 1913 1738 3 -1498 460 355 1947 3 -522 261 245 1609 3 -1219 1035 1091 670 3 -166 190 1205 1462 3 -166 1205 1066 1299 3 -27 871 1114 852 3 -837 948 566 1175 3 -981 1357 789 1607 3 -822 284 198 611 3 -1388 590 492 1053 3 -1678 1585 1562 556 3 -730 1023 16 1161 3 -1761 1058 894 939 3 -520 1927 19 1000 3 -1496 1861 709 154 3 -380 1466 399 870 3 -993 482 1252 816 3 -1600 879 1426 1088 3 -854 774 44 1254 3 -1913 731 1193 1598 3 -652 776 1531 1490 3 -458 1451 274 1166 3 -44 774 1008 1254 3 -698 8 1238 594 3 -390 1697 323 1535 3 -998 1873 767 1215 3 -538 1664 793 1768 3 -774 1806 1201 713 3 -132 396 290 1702 3 -473 850 558 905 3 -1514 1051 728 1392 3 -1256 305 825 225 3 -1506 356 1731 794 3 -375 934 1337 607 3 -542 741 511 978 3 -712 1460 1355 1269 3 -397 132 746 1702 3 -287 978 741 542 3 -17 472 1336 1918 3 -1235 854 1257 1254 3 -623 1589 1671 1004 3 -1257 1004 848 693 3 -454 762 607 149 3 -672 1598 1610 1556 3 -1897 1748 556 1486 3 -710 1757 1713 1424 3 -124 1812 346 1231 3 -1401 197 1186 1221 3 -276 518 293 1791 3 -622 1501 1304 1577 3 -1206 524 1531 372 3 -571 1427 1170 566 3 -1092 1540 678 669 3 -495 977 440 1045 3 -1800 192 1818 1152 3 -1080 1691 1152 1148 3 -921 1793 1675 1291 3 -27 871 169 1114 3 -1283 12 1645 1468 3 -1290 701 1389 1364 3 -1325 1391 1059 1433 3 -383 995 1248 1753 3 -1232 1429 218 300 3 -1558 107 1862 146 3 -1388 1098 51 1249 3 -1567 577 398 1554 3 -1350 887 1424 1109 3 -1816 1754 1627 1255 3 -1153 716 1125 697 3 -703 817 1953 598 3 -411 919 1363 1861 3 -620 336 1087 1641 3 -1905 609 513 352 3 -1686 63 713 305 3 -493 1129 635 1015 3 -523 1702 1568 496 3 -1636 979 3 600 3 -1838 1667 1669 1611 3 -586 1631 1733 1334 3 -980 1575 602 1688 3 -392 102 1292 126 3 -1366 448 44 854 3 -152 732 1179 1157 3 -135 1920 116 737 3 -744 1832 1902 1160 3 -967 895 381 506 3 -1413 1605 618 600 3 -989 1173 876 1824 3 -1245 556 1486 840 3 -383 1481 653 1189 3 -1626 1243 1117 936 3 -949 938 22 1928 3 -1902 1882 1548 1028 3 -644 853 1376 1423 3 -1453 107 716 1689 3 -1138 721 212 1935 3 -1203 933 294 1284 3 -428 1088 1260 879 3 -591 487 1478 1008 3 -653 673 448 784 3 -952 1155 1126 1639 3 -854 890 1007 643 3 -918 1275 568 1618 3 -568 1618 440 495 3 -1611 53 953 587 3 -647 1385 1946 1265 3 -377 1241 1320 881 3 -589 1058 939 842 3 -521 677 1741 777 3 -1079 975 752 1286 3 -74 1891 844 1493 3 -1631 176 831 175 3 -1226 565 1561 1431 3 -1869 1929 187 47 3 -1345 1121 71 446 3 -639 592 1713 953 3 -1948 558 810 1616 3 -783 1019 507 1393 3 -490 1917 1190 42 3 -392 102 1460 1292 3 -164 183 1352 868 3 -705 1113 1298 1308 3 -263 1429 1018 7 3 -475 1360 559 55 3 -1219 486 940 842 3 -1784 665 1785 923 3 -601 1164 1158 1523 3 -639 876 1561 1713 3 -1124 819 952 33 3 -1642 640 727 934 3 -173 529 791 1242 3 -1495 668 1457 812 3 -1651 615 123 826 3 -1685 1709 415 840 3 -1049 1684 715 1782 3 -1290 1364 1760 357 3 -973 944 803 586 3 -705 1417 452 1657 3 -743 27 722 1146 3 -1014 1487 1108 1016 3 -283 1150 869 40 3 -1079 797 1286 246 3 -1138 1935 212 1253 3 -811 1517 1297 1710 3 -1487 1941 1016 1211 3 -519 246 1286 204 3 -1389 1504 588 1364 3 -935 79 645 1295 3 -309 880 994 242 3 -1621 1333 690 635 3 -1279 650 1620 1136 3 -1399 1126 33 1241 3 -1853 1159 836 1538 3 -1630 1817 1046 1011 3 -451 1130 1430 1872 3 -1615 1134 1368 1419 3 -1671 1516 1789 1471 3 -1278 650 806 1148 3 -954 1361 1940 1215 3 -431 1673 976 209 3 -1957 195 1030 59 3 -476 1621 635 1858 3 -115 841 614 147 3 -1182 76 1717 1956 3 -267 564 541 1131 3 -1631 839 1586 1376 3 -1861 1539 410 1496 3 -991 1949 68 779 3 -828 1887 899 671 3 -1404 666 1477 930 3 -1202 1937 1604 1592 3 -1667 53 1611 1294 3 -1207 761 17 1194 3 -240 293 1634 1924 3 -1937 1564 1528 1202 3 -605 700 662 934 3 -700 739 180 753 3 -699 1877 539 1146 3 -1632 1947 460 1708 3 -912 974 165 1743 3 -1004 985 591 1257 3 -126 1476 391 1246 3 -1390 1387 757 900 3 -1908 1442 717 1616 3 -145 1133 1139 1341 3 -449 445 343 1416 3 -1630 1367 1322 478 3 -1272 889 161 210 3 -1375 1718 22 738 3 -382 960 251 1647 3 -595 810 919 1688 3 -1375 1462 22 1718 3 -1531 964 360 524 3 -125 1119 1548 1369 3 -1155 841 1514 757 3 -1873 330 998 150 3 -190 804 885 1066 3 -949 893 787 1028 3 -532 1231 1093 1308 3 -69 640 70 1006 3 -264 1551 1015 78 3 -422 749 699 539 3 -929 1015 206 873 3 -24 12 1821 1159 3 -1476 482 1292 1355 3 -297 1939 239 1303 3 -671 1346 1139 947 3 -986 1350 888 1435 3 -987 980 423 1363 3 -1374 1739 931 1783 3 -1243 1552 9 621 3 -35 191 543 744 3 -599 1674 1385 82 3 -66 504 1593 691 3 -1029 1507 1142 749 3 -188 187 871 25 3 -188 187 169 871 3 -1593 1545 512 100 3 -595 1457 810 1688 3 -684 368 95 1529 3 -719 29 766 108 3 -882 1089 1164 1490 3 -1645 636 1750 1283 3 -1043 1022 1171 214 3 -1355 1460 1292 392 3 -119 491 319 1560 3 -1837 1248 1181 1773 3 -267 564 1131 233 3 -853 1631 586 644 3 -872 1455 714 1552 3 -423 1087 336 1539 3 -1782 914 1684 715 3 -408 1333 1889 690 3 -1605 1413 799 600 3 -1334 831 315 903 3 -1016 1866 474 1941 3 -1705 1188 607 454 3 -719 106 107 766 3 -285 1293 138 1165 3 -115 841 957 614 3 -719 108 766 109 3 -317 1719 619 491 3 -1125 130 697 106 3 -1149 678 562 1540 3 -1636 1687 3 1355 3 -697 106 766 716 3 -697 29 108 766 3 -719 766 1689 771 3 -964 932 1693 1690 3 -1096 179 1903 1938 3 -719 29 106 766 3 -26 719 771 109 3 -557 869 208 283 3 -97 524 1726 160 3 -973 924 1733 803 3 -107 766 106 716 3 -1810 1433 59 71 3 -1275 742 440 326 3 -538 507 1664 1768 3 -1346 633 1139 684 3 -1753 995 1132 383 3 -1003 979 513 1379 3 -1636 1438 3 979 3 -1447 1340 849 696 3 -317 491 1263 319 3 -1306 1528 1629 1474 3 -1175 948 1511 837 3 -494 1212 1855 772 3 -1374 335 233 1131 3 -878 246 1286 519 3 -1129 653 1189 1865 3 -1405 484 793 474 3 -1326 1281 1153 786 3 -1751 1735 1846 585 3 -1456 1258 991 349 3 -1136 1126 915 1176 3 -1491 1519 1623 783 3 -1940 1880 34 298 3 -1217 756 18 1519 3 -905 1616 1817 1542 3 -714 1898 1291 1746 3 -1461 1722 655 986 3 -705 1285 1657 1344 3 -509 882 1458 1164 3 -304 929 73 1195 3 -1215 954 765 1047 3 -1906 1340 849 257 3 -541 774 44 713 3 -840 1486 1585 556 3 -1168 1436 1723 1342 3 -383 702 929 529 3 -862 41 213 299 3 -947 1910 434 968 3 -1922 1400 755 1685 3 -774 267 541 1131 3 -308 270 1572 238 3 -732 718 1253 536 3 -1585 1681 1625 1834 3 -731 443 1577 492 3 -399 1390 870 1425 3 -298 214 1880 34 3 -683 1430 1093 1943 3 -1774 14 1576 1109 3 -709 785 424 1861 3 -882 509 479 14 3 -1570 1291 1040 1370 3 -1412 825 511 44 3 -130 1125 32 287 3 -163 1248 529 702 3 -912 1543 164 48 3 -698 1238 807 453 3 -1722 1701 1672 618 3 -1468 464 1645 5 3 -286 1125 130 287 3 -64 1249 1055 1769 3 -1810 506 1639 758 3 -555 1776 734 579 3 -912 165 1543 1743 3 -1487 1941 1108 1016 3 -1224 992 572 721 3 -1332 904 1720 1824 3 -1502 549 1060 457 3 -1281 542 926 786 3 -183 889 868 210 3 -1145 547 1703 1886 3 -868 912 164 48 3 -489 1694 956 1212 3 -167 620 531 1240 3 -1134 803 973 944 3 -167 186 1240 593 3 -1573 788 806 1278 3 -373 1491 1625 1314 3 -592 784 876 354 3 -473 1796 429 401 3 -415 1103 605 1740 3 -377 1241 1233 1559 3 -757 841 895 1155 3 -1807 87 562 144 3 -1853 1538 836 37 3 -1442 280 1489 10 3 -464 1890 1796 5 3 -463 360 1039 1724 3 -1698 1780 23 1786 3 -163 171 1904 1870 3 -950 1727 846 534 3 -1038 1788 554 1737 3 -556 1486 1562 1897 3 -402 703 598 438 3 -1736 899 1887 671 3 -288 1000 1020 1772 3 -597 1124 952 33 3 -1091 589 939 842 3 -1187 1854 932 1498 3 -597 1403 1155 952 3 -405 1111 799 1414 3 -620 186 785 1240 3 -974 947 671 1139 3 -659 971 950 852 3 -943 701 1380 65 3 -1380 701 1025 65 3 -1535 705 1308 1344 3 -991 853 1177 537 3 -69 334 161 101 3 -1908 104 1442 1616 3 -1064 670 254 1545 3 -520 567 1540 19 3 -136 1908 717 1616 3 -1289 1564 602 1801 3 -491 802 1881 1294 3 -1389 935 645 701 3 -1526 533 907 1527 3 -1849 102 482 1460 3 -805 1076 1872 835 3 -818 824 964 1690 3 -1047 521 1439 1749 3 -136 104 1908 1616 3 -711 670 202 1064 3 -848 582 585 1778 3 -935 530 943 1290 3 -1389 1009 1504 701 3 -755 1239 457 1450 3 -1178 548 1732 1251 3 -1253 1935 263 1169 3 -1450 755 1239 1013 3 -473 558 1616 905 3 -818 1690 964 160 3 -185 8 1238 698 3 -1613 15 1663 805 3 -681 656 806 814 3 -1753 1248 1779 1428 3 -1279 1137 1136 510 3 -427 858 1251 1199 3 -1438 1547 993 1252 3 -462 423 1539 410 3 -259 923 6 314 3 -549 1313 1354 1502 3 -1685 840 415 833 3 -1294 53 1611 587 3 -311 860 695 1467 3 -9 902 1328 1549 3 -524 818 160 1349 3 -376 374 1460 792 3 -551 667 684 368 3 -1154 1525 550 1736 3 -475 678 941 926 3 -1308 1231 546 532 3 -943 867 1128 1105 3 -83 1295 935 613 3 -1060 894 1338 457 3 -972 1264 374 792 3 -1245 1103 1381 415 3 -324 1872 451 1430 3 -1275 325 440 1618 3 -1644 668 1210 1031 3 -1637 945 1085 553 3 -977 325 1894 1618 3 -1314 1654 1804 1210 3 -863 586 1788 644 3 -1495 1542 1457 810 3 -490 1863 42 802 3 -1500 1367 1859 1280 3 -809 1929 187 1869 3 -1623 975 1408 1286 3 -900 692 837 577 3 -480 1593 49 375 3 -1790 1597 1698 1933 3 -472 1122 901 1537 3 -1764 423 1896 1801 3 -1795 1380 566 1923 3 -193 192 725 1152 3 -1275 440 1288 568 3 -812 668 1646 1571 3 -551 684 633 414 3 -1606 776 1556 1260 3 -568 1288 1306 1037 3 -1498 1854 928 1658 3 -1776 851 579 1365 3 -936 1243 1643 1746 3 -292 670 1545 254 3 -765 1749 1047 1439 3 -604 726 611 992 3 -1848 1924 770 913 3 -1101 1639 895 1155 3 -138 96 617 598 3 -152 1157 1311 732 3 -1727 1700 1216 1550 3 -1511 948 1175 1362 3 -1133 828 1139 1341 3 -1678 1088 1154 548 3 -442 1715 1760 357 3 -1175 1703 965 1472 3 -326 388 1330 1140 3 -543 22 1375 917 3 -1245 1743 1740 500 3 -484 712 799 3 3 -1394 1192 864 1886 3 -1740 500 1273 1245 3 -290 396 328 1568 3 -1697 1944 859 730 3 -427 1199 1019 782 3 -715 1789 1596 1819 3 -531 999 22 1928 3 -715 1789 1819 623 3 -264 289 1551 78 3 -876 1226 1561 1431 3 -965 867 1038 1270 3 -573 1082 1314 641 3 -1485 1725 777 150 3 -269 283 234 628 3 -490 802 1373 754 3 -786 1670 569 19 3 -929 1017 625 1827 3 -1743 974 177 947 3 -1736 1711 550 671 3 -827 962 1957 1657 3 -83 613 935 1062 3 -1692 1501 731 1770 3 -1788 944 1737 1364 3 -1513 1170 1380 1787 3 -117 116 823 706 3 -1069 1333 1889 1826 3 -326 1330 977 1140 3 -1889 1333 408 1826 3 -234 283 1082 628 3 -1788 867 1506 1364 3 -1422 1085 1129 673 3 -1659 1936 368 798 3 -1551 1806 1201 1007 3 -146 1689 1194 25 3 -185 694 807 1238 3 -601 1164 1953 1158 3 -977 1894 497 1618 3 -1384 1654 36 514 3 -1121 956 1059 494 3 -1194 1689 1122 25 3 -1340 471 696 770 3 -498 1292 126 611 3 -1740 1743 912 500 3 -448 653 477 1661 3 -738 1057 629 1060 3 -730 568 1306 1023 3 -669 1540 678 1773 3 -1168 689 1723 874 3 -836 1072 360 778 3 -1287 1617 1312 645 3 -1814 1233 1522 1559 3 -1247 1462 1375 1718 3 -256 1739 1534 72 3 -1617 530 935 613 3 -661 865 1397 1083 3 -699 743 1877 1146 3 -879 1650 42 928 3 -1287 1295 645 561 3 -1004 1254 1235 1257 3 -902 217 1328 522 3 -225 1827 1915 825 3 -847 617 509 479 3 -1786 1628 655 1594 3 -366 1024 1261 1107 3 -1824 1488 1332 1883 3 -290 396 1568 1702 3 -1595 566 1380 943 3 -927 1026 1847 959 3 -1354 1502 1137 56 3 -1481 653 1189 1661 3 -875 1011 473 1817 3 -1440 1056 74 1032 3 -1117 1319 1626 936 3 -414 1046 636 1011 3 -1786 1628 1594 1268 3 -918 30 45 568 3 -818 1206 509 847 3 -1529 368 95 94 3 -742 747 1330 388 3 -825 541 511 44 3 -1188 1365 1359 1296 3 -256 687 1083 72 3 -1550 534 1208 1599 3 -1378 1068 1794 1644 3 -80 1188 1376 642 3 -1034 1013 416 1450 3 -935 943 65 701 3 -43 725 1800 917 3 -652 1490 509 1164 3 -1825 1595 1831 1446 3 -1449 986 888 1435 3 -1739 282 1534 996 3 -1070 1710 1662 1174 3 -9 874 1436 886 3 -1284 1145 763 933 3 -81 240 1166 273 3 -385 956 1121 1347 3 -1691 461 1266 650 3 -1560 907 724 1885 3 -149 1705 180 739 3 -1811 1688 861 668 3 -642 1705 1188 753 3 -1455 1452 872 1449 3 -699 122 1877 743 3 -1046 636 905 1019 3 -1479 1673 976 431 3 -952 1101 1683 1574 3 -996 1655 1864 1348 3 -620 1641 1087 186 3 -41 213 1453 862 3 -968 1842 1910 215 3 -1578 1441 577 647 3 -696 965 849 555 3 -1847 1026 1855 959 3 -1904 1837 1181 1838 3 -590 1419 1493 1055 3 -171 736 1198 1428 3 -1216 1142 1672 683 3 -566 948 1270 1175 3 -1227 851 1586 362 3 -790 1084 1149 606 3 -1548 855 1494 1028 3 -1217 756 1519 1274 3 -1524 554 800 803 3 -1714 855 626 497 3 -523 553 1050 1781 3 -913 1924 1340 933 3 -1378 1794 938 1377 3 -1618 497 819 1086 3 -1133 828 1341 437 3 -200 245 1063 314 3 -1086 497 1124 855 3 -562 413 86 520 3 -450 750 1395 459 3 -883 158 958 1497 3 -450 750 459 563 3 -912 1743 1543 48 3 -339 1369 1112 891 3 -595 810 1457 1071 3 -1592 942 820 881 3 -345 1350 1576 887 3 -1554 1394 1443 577 3 -992 1905 816 721 3 -1390 841 488 957 3 -950 532 846 1727 3 -1310 734 1533 223 3 -903 315 1820 1499 3 -759 1095 1621 148 3 -1037 1474 1320 1937 3 -1310 579 223 275 3 -1915 825 625 1201 3 -1748 671 1178 1245 3 -1932 1087 423 1801 3 -827 1276 1223 1030 3 -1576 1234 345 1721 3 -924 1419 443 1426 3 -1422 673 653 784 3 -45 195 827 1147 3 -727 516 334 1642 3 -417 190 1462 917 3 -1108 1941 1866 1016 3 -606 790 52 736 3 -1573 1876 788 796 3 -1029 674 1507 749 3 -1245 1409 801 1500 3 -546 1899 1812 1475 3 -1945 1822 405 1414 3 -334 658 762 1593 3 -266 230 1256 305 3 -1790 1813 1445 1463 3 -666 1477 760 1404 3 -810 1442 1542 1071 3 -1014 1162 1016 1108 3 -114 1390 399 1387 3 -1761 1321 894 1058 3 -70 889 183 1006 3 -989 1040 487 1370 3 -1346 671 1178 1748 3 -395 1603 1606 1260 3 -783 1623 815 478 3 -644 1631 1586 1376 3 -442 1715 1389 1760 3 -1064 573 670 1627 3 -810 1616 1542 1442 3 -1070 764 1608 1734 3 -567 1779 1823 954 3 -397 132 1702 396 3 -1268 1603 395 1463 3 -1241 1172 881 1662 3 -221 880 1509 994 3 -580 1479 1266 1403 3 -68 657 991 779 3 -523 1855 693 1735 3 -586 1586 1506 1788 3 -1274 238 1079 1939 3 -1136 1432 1126 1176 3 -407 561 1312 342 3 -475 678 1132 941 3 -1119 1680 1882 1073 3 -1789 1503 1671 1471 3 -1698 1488 23 1780 3 -1836 277 227 313 3 -827 1957 1417 1657 3 -986 1089 1530 1461 3 -1835 1602 1517 811 3 -80 1229 839 1376 3 -660 1532 1217 663 3 -374 1460 712 1269 3 -1262 1452 1455 1449 3 -1138 212 352 830 3 -603 1710 1297 1608 3 -317 491 1863 1263 3 -1876 77 920 796 3 -747 698 807 441 3 -1192 1105 1472 867 3 -952 1126 1620 33 3 -11 1168 262 1723 3 -1347 956 914 772 3 -1188 1327 1365 1376 3 -830 212 1253 1138 3 -1650 928 1556 1658 3 -452 1657 446 1782 3 -816 1905 1138 721 3 -882 1774 886 888 3 -910 576 1797 668 3 -1532 1255 1754 1217 3 -1269 1460 1355 392 3 -11 1168 1723 1342 3 -350 538 782 1546 3 -476 676 635 1085 3 -939 127 62 1566 3 -1517 948 1362 1038 3 -1785 665 227 1271 3 -550 671 974 1743 3 -405 1111 1414 1822 3 -441 807 1330 1932 3 -1710 1517 1512 811 3 -288 1326 1020 1000 3 -1700 1712 846 1216 3 -557 1654 514 1150 3 -857 1167 1081 681 3 -1870 1135 995 702 3 -331 422 539 1430 3 -1389 935 701 1290 3 -1115 13 255 1874 3 -287 1125 32 542 3 -570 371 1206 372 3 -129 519 878 1856 3 -1338 1627 1255 1816 3 -1253 1230 1429 732 3 -649 38 140 829 3 -1644 1495 1491 373 3 -1269 817 1355 1687 3 -1701 1550 1262 1216 3 -1073 543 1094 1339 3 -1129 635 1015 676 3 -1395 1692 899 1887 3 -1124 952 1324 597 3 -363 243 258 1116 3 -884 1505 1309 1331 3 -813 1105 1652 425 3 -531 1928 22 1031 3 -1364 867 1506 1128 3 -1095 1323 1333 635 3 -481 173 162 907 3 -1422 673 1129 653 3 -37 1027 1853 750 3 -1769 318 490 1863 3 -697 1675 1153 716 3 -141 133 691 62 3 -139 92 1906 547 3 -1604 1564 1928 540 3 -1750 1283 636 350 3 -712 1269 1355 1687 3 -884 1505 1331 438 3 -620 531 348 167 3 -712 1687 866 1269 3 -285 1158 1077 138 3 -907 1560 791 832 3 -1206 371 652 598 3 -862 299 1647 233 3 -936 300 1117 219 3 -935 530 1290 1062 3 -1404 1477 1538 1159 3 -844 1891 1677 1493 3 -869 111 514 143 3 -324 859 1663 1613 3 -412 1128 357 1731 3 -271 1473 704 663 3 -1842 215 968 1353 3 -784 1002 876 354 3 -1279 650 728 1620 3 -665 1168 1436 874 3 -1357 913 933 293 3 -1499 357 1760 356 3 -1442 280 1623 1489 3 -704 1553 660 1754 3 -89 1955 156 1950 3 -538 636 905 866 3 -564 1871 685 581 3 -1267 539 552 1146 3 -1299 861 910 20 3 -684 1845 633 414 3 -726 1 284 1879 3 -377 1033 1023 1320 3 -1136 1279 1126 1620 3 -1294 1611 1912 587 3 -939 589 127 1566 3 -652 776 1490 1107 3 -1173 1449 1040 1431 3 -115 502 77 957 3 -1640 1223 583 827 3 -1381 1525 39 1103 3 -800 863 1213 1777 3 -345 1707 1823 1721 3 -1614 1698 1488 23 3 -715 1401 1684 1049 3 -1400 1337 896 1434 3 -623 1589 1004 693 3 -611 1482 1523 689 3 -1648 534 1216 1599 3 -823 489 1347 772 3 -612 1740 912 605 3 -54 1590 528 271 3 -1241 1662 881 1233 3 -1639 58 1126 1559 3 -1619 1042 846 1700 3 -1287 645 1312 561 3 -106 1465 716 856 3 -1624 188 1311 152 3 -374 792 712 1460 3 -1077 598 426 438 3 -573 1314 18 641 3 -1852 813 1731 157 3 -816 1138 536 1191 3 -132 1702 290 661 3 -782 1199 1019 350 3 -531 1289 1031 861 3 -898 819 952 1086 3 -1138 830 352 536 3 -1102 1569 1238 594 3 -1139 633 671 828 3 -1004 985 1257 848 3 -1029 184 751 674 3 -1111 1414 1822 468 3 -513 482 1905 1252 3 -1812 390 346 1231 3 -482 609 513 1905 3 -798 12 970 1315 3 -164 181 779 1352 3 -1842 1353 1743 48 3 -1218 710 1070 1583 3 -1529 1845 1346 684 3 -1691 1005 1266 461 3 -220 1646 1571 281 3 -853 1631 925 1733 3 -475 1360 1132 559 3 -1214 1222 241 1447 3 -1263 1885 319 1560 3 -650 1620 1494 597 3 -1906 1227 85 734 3 -1436 1723 886 874 3 -1314 1338 1804 1654 3 -1301 1047 998 521 3 -566 1795 1270 948 3 -1670 1746 1243 1552 3 -823 737 1892 693 3 -1013 1104 695 1359 3 -612 912 779 1352 3 -941 648 1110 1766 3 -423 1238 987 462 3 -1261 1107 1695 1283 3 -784 1637 1846 1751 3 -591 1008 1254 1366 3 -1257 1235 1004 693 3 -1150 111 514 869 3 -1725 1541 777 150 3 -343 735 724 1095 3 -1036 60 843 677 3 -1636 1953 1687 1355 3 -1714 1882 855 1894 3 -709 186 708 861 3 -259 1117 228 219 3 -1630 1046 815 1019 3 -383 529 1865 832 3 -690 65 745 945 3 -925 1631 853 515 3 -1363 919 980 1861 3 -1041 714 1746 1898 3 -1034 857 1354 1321 3 -988 1863 754 1263 3 -1515 610 993 1547 3 -1159 1072 836 778 3 -771 1067 1689 1120 3 -768 1524 1582 1368 3 -785 861 186 709 3 -1737 1923 1504 554 3 -1147 195 827 962 3 -1910 1280 1755 215 3 -366 1024 1209 1261 3 -851 1586 362 1074 3 -329 455 339 1086 3 -120 1386 337 1300 3 -860 81 1166 274 3 -1630 1199 1046 1019 3 -864 403 1472 1105 3 -730 1288 1306 568 3 -1085 676 1129 673 3 -896 1038 1517 365 3 -169 871 1869 733 3 -783 1322 1019 501 3 -475 926 511 646 3 -645 632 935 1617 3 -1636 979 600 1672 3 -1117 1520 1874 300 3 -1905 1138 536 816 3 -720 1311 732 152 3 -511 926 542 646 3 -1943 1507 683 1430 3 -1244 872 714 1552 3 -1768 558 474 905 3 -1159 1477 1072 1821 3 -320 1001 322 492 3 -1502 510 1137 56 3 -259 923 439 1117 3 -1346 671 1748 1409 3 -1214 860 908 695 3 -165 177 1543 1743 3 -288 829 1326 1000 3 -591 904 487 989 3 -580 1403 1266 597 3 -125 1894 1180 630 3 -1732 1088 1770 1260 3 -1528 1484 1544 1665 3 -1050 1021 1637 854 3 -1087 336 620 615 3 -1638 104 10 250 3 -1132 1360 1950 559 3 -1770 1088 1426 879 3 -613 632 1617 530 3 -1024 930 858 1261 3 -1286 878 752 246 3 -1646 910 1571 668 3 -850 1309 1763 5 3 -1423 753 1327 1337 3 -1927 569 1000 1772 3 -1149 1540 562 567 3 -1762 2 1911 850 3 -1337 1151 1423 795 3 -1504 545 1583 1521 3 -613 632 1204 1617 3 -816 721 1138 572 3 -1205 1066 804 190 3 -1209 1199 427 782 3 -127 1091 62 292 3 -1613 805 835 1306 3 -586 1733 973 1334 3 -1130 451 1822 468 3 -1473 254 54 704 3 -1605 1945 1448 1379 3 -1293 689 1723 262 3 -837 692 1427 1511 3 -46 562 1149 627 3 -1775 1701 1262 1216 3 -141 100 254 1545 3 -1004 693 1235 706 3 -1496 1087 709 1861 3 -382 1647 233 862 3 -1165 1293 262 198 3 -282 251 233 1771 3 -1493 470 1891 1677 3 -1452 986 1530 888 3 -324 631 835 1430 3 -288 1772 255 200 3 -465 391 1269 884 3 -1175 948 1270 1362 3 -967 895 506 758 3 -534 378 1336 1097 3 -381 1390 841 870 3 -345 1234 1707 1721 3 -324 1872 1430 835 3 -386 1947 355 460 3 -1299 576 531 1462 3 -473 850 905 636 3 -235 31 997 308 3 -681 1081 656 814 3 -1390 757 488 841 3 -926 786 1092 941 3 -1204 632 1312 1617 3 -398 1441 637 1394 3 -58 692 757 1126 3 -1298 1223 1033 1417 3 -1944 15 1288 742 3 -1440 1009 1032 754 3 -611 1476 126 1555 3 -706 693 1235 687 3 -523 1050 1735 693 3 -694 1421 1076 1629 3 -1444 1576 1774 14 3 -1950 1360 222 559 3 -1789 1589 1382 1671 3 -49 1754 1627 1816 3 -759 407 616 1826 3 -1674 1356 575 845 3 -1248 702 995 383 3 -1553 608 415 1685 3 -616 1826 408 1621 3 -589 508 1058 940 3 -711 40 291 1219 3 -789 692 1387 981 3 -1298 1033 1143 1417 3 -488 1387 1357 789 3 -1071 1638 10 250 3 -31 234 628 269 3 -711 40 1219 1082 3 -234 40 291 711 3 -1206 598 652 509 3 -1887 432 1501 1420 3 -1860 1687 1953 817 3 -181 70 180 700 3 -779 1949 1259 912 3 -1769 1098 1249 490 3 -500 801 1842 1273 3 -1434 1365 1776 555 3 -164 181 1352 183 3 -1696 909 1182 758 3 -1173 986 1431 338 3 -365 1104 555 1752 3 -707 549 1060 1313 3 -1095 686 791 1323 3 -1001 1304 1300 443 3 -1482 601 1953 1158 3 -82 76 1952 1265 3 -690 65 892 745 3 -360 359 932 1039 3 -1513 1883 1787 354 3 -372 371 1206 97 3 -557 1082 1654 1150 3 -1750 1653 1659 1878 3 -434 1859 1755 1910 3 -264 1015 206 78 3 -1261 930 858 1199 3 -1275 1944 1288 742 3 -877 276 814 242 3 -1498 1947 355 966 3 -1147 827 583 1285 3 -812 1196 1491 373 3 -1628 1921 1933 1484 3 -1503 1671 1054 1478 3 -701 645 65 935 3 -1856 519 1411 260 3 -1426 1368 1419 1193 3 -377 1023 1474 1320 3 -977 505 497 1714 3 -430 206 1015 248 3 -776 366 1209 1603 3 -1017 1189 929 625 3 -841 870 757 895 3 -540 543 22 949 3 -1139 1133 145 680 3 -292 1091 1545 670 3 -1052 1225 1394 1446 3 -650 1148 1028 787 3 -1315 24 798 12 3 -936 1520 1117 300 3 -941 511 648 1412 3 -1337 1151 795 608 3 -498 611 126 1228 3 -1385 599 1446 1831 3 -1148 650 806 1279 3 -1020 569 769 1772 3 -1578 1946 571 969 3 -1279 1148 650 1136 3 -1050 553 1021 890 3 -1148 787 1313 629 3 -1652 92 1510 93 3 -163 1248 1527 529 3 -676 1551 1021 1563 3 -890 553 1021 1563 3 -1191 740 1041 341 3 -1522 585 582 1778 3 -739 180 70 700 3 -1135 995 1132 1955 3 -432 1577 1692 1501 3 -710 1218 1600 1373 3 -66 133 691 141 3 -1454 297 1303 1842 3 -606 736 1779 1149 3 -1132 1766 1481 1412 3 -1858 430 686 635 3 -633 899 671 828 3 -748 1632 51 178 3 -86 128 413 38 3 -711 1064 997 573 3 -24 12 1315 1821 3 -1593 66 141 100 3 -387 844 1677 447 3 -1050 1021 854 890 3 -1059 1185 1433 1143 3 -378 1727 534 1550 3 -1913 51 1738 1027 3 -1295 645 935 1617 3 -1097 1727 950 534 3 -1163 880 526 309 3 -1194 472 17 1207 3 -597 1548 1494 461 3 -1957 195 59 962 3 -1310 734 85 1533 3 -1444 1187 14 824 3 -1070 1583 1795 1524 3 -779 181 700 1352 3 -585 1728 1847 1855 3 -1142 1448 1010 1672 3 -1037 1474 1937 1528 3 -1437 909 1391 956 3 -581 1829 921 648 3 -1643 1557 1742 485 3 -636 850 905 866 3 -552 1029 1418 1142 3 -808 798 367 1936 3 -370 1121 446 1782 3 -1370 1008 1766 648 3 -617 509 1164 598 3 -737 1397 687 729 3 -989 904 1824 1002 3 -1361 664 1721 954 3 -1437 909 956 1694 3 -1535 583 1308 705 3 -1128 1105 1852 412 3 -823 489 772 693 3 -1654 1622 514 1384 3 -593 186 1240 861 3 -1162 1108 1866 1016 3 -399 1425 398 1567 3 -957 614 920 77 3 -1049 1401 1899 1186 3 -264 625 1015 1551 3 -1917 966 1190 1584 3 -873 625 1015 264 3 -423 1896 1801 980 3 -196 461 1548 597 3 -536 1138 1253 1230 3 -1646 910 1457 1071 3 -1134 1615 545 1009 3 -983 1900 1036 1526 3 -1770 1426 731 879 3 -1387 981 1567 1357 3 -1311 1581 852 1157 3 -1033 1639 1399 1559 3 -181 574 182 657 3 -731 1419 492 1193 3 -1508 1537 901 596 3 -521 777 1741 1439 3 -1136 1620 1126 1432 3 -101 1593 516 100 3 -1438 1482 1953 1476 3 -469 344 1683 982 3 -963 1395 672 899 3 -341 740 1041 1898 3 -1056 449 988 1032 3 -370 1347 1121 1782 3 -1626 992 937 572 3 -454 316 1305 1359 3 -423 1087 980 1801 3 -1626 1243 923 1117 3 -226 822 1785 1224 3 -399 1387 1425 1567 3 -1151 39 795 608 3 -1535 1285 705 1344 3 -1119 1680 1073 35 3 -1560 53 791 832 3 -971 722 834 332 3 -771 761 1689 1067 3 -1393 538 782 1019 3 -488 1876 920 789 3 -1323 1242 1865 635 3 -1264 2 1895 1358 3 -9 665 1784 923 3 -981 1703 1175 1886 3 -383 1470 1865 653 3 -1696 1182 967 758 3 -248 90 503 1183 3 -461 650 597 1266 3 -1235 854 1254 643 3 -685 648 541 581 3 -1918 1336 487 436 3 -26 719 1689 771 3 -1253 1429 263 7 3 -1827 1256 916 825 3 -1264 1895 465 1269 3 -539 122 1942 1877 3 -1032 1009 1156 781 3 -1785 1065 227 665 3 -988 317 318 1863 3 -1698 1757 1078 1786 3 -784 1751 1846 354 3 -953 984 1787 1025 3 -300 1169 1018 219 3 -1361 435 1690 824 3 -1345 1121 370 385 3 -1627 1091 670 1545 3 -350 636 538 866 3 -1628 1484 655 1744 3 -235 1064 254 1473 3 -1452 888 1552 872 3 -65 984 1787 1751 3 -1636 1775 1672 1722 3 -120 1386 1934 353 3 -1545 49 1593 512 3 -947 1679 145 434 3 -1831 1674 1954 1385 3 -225 305 713 231 3 -399 870 1466 1425 3 -476 91 690 1621 3 -1023 1640 583 730 3 -715 1347 914 772 3 -1836 217 277 313 3 -784 989 876 1002 3 -33 942 1241 1126 3 -86 520 413 128 3 -1865 1129 635 493 3 -1454 48 210 297 3 -593 861 1299 20 3 -1227 1533 85 734 3 -1037 1937 626 505 3 -879 1650 928 1556 3 -732 1418 1230 1716 3 -1090 525 1701 618 3 -596 1716 1557 1508 3 -878 815 1630 1817 3 -1383 170 34 1880 3 -808 1404 760 1538 3 -784 448 1366 854 3 -1790 1813 1174 1445 3 -633 1732 671 899 3 -1025 645 65 701 3 -56 908 1354 1809 3 -1083 865 1397 687 3 -1671 1516 1382 1789 3 -880 1818 1509 1278 3 -1175 1192 1472 867 3 -121 315 973 1334 3 -1668 1062 1290 412 3 -791 832 1323 1242 3 -293 1634 933 203 3 -293 1924 913 933 3 -1853 836 463 37 3 -1659 414 1878 368 3 -1323 832 1865 1242 3 -999 531 348 620 3 -454 1296 1359 310 3 -585 354 876 1002 3 -553 1563 1200 676 3 -935 530 65 943 3 -1367 624 1280 1500 3 -510 56 1607 1137 3 -634 527 11 617 3 -304 1017 929 1827 3 -1212 1185 494 1778 3 -983 1527 1526 358 3 -174 442 1612 844 3 -1176 1172 1241 1662 3 -1792 1859 1367 1830 3 -1698 1078 1790 1786 3 -58 757 1155 1126 3 -935 632 65 530 3 -608 415 605 727 3 -1689 761 1194 1122 3 -1522 1660 1488 585 3 -1685 840 833 406 3 -878 1630 815 478 3 -1020 1643 1115 769 3 -1130 422 451 1430 3 -343 735 1095 759 3 -181 180 182 574 3 -1350 1431 338 1561 3 -926 829 786 542 3 -736 1779 567 1383 3 -392 1355 1269 391 3 -1207 1868 1829 581 3 -776 1024 366 1107 3 -76 1717 1956 1265 3 -1222 1924 1340 770 3 -979 1379 799 1605 3 -613 530 935 1062 3 -1057 1579 1176 603 3 -520 1000 413 128 3 -520 1927 1000 278 3 -1438 1003 3 979 3 -856 1281 1125 741 3 -856 41 1871 286 3 -1520 1643 1117 769 3 -605 934 608 727 3 -621 1552 9 1805 3 -934 605 889 727 3 -1035 1082 1219 1654 3 -1742 1670 1020 786 3 -551 1936 368 1659 3 -835 1629 683 16 3 -933 1634 1340 203 3 -390 631 346 1231 3 -803 863 946 1733 3 -855 497 1124 33 3 -1900 533 907 1526 3 -1326 1125 32 697 3 -1262 1515 1455 1452 3 -1885 724 333 907 3 -595 361 154 250 3 -1809 1013 1104 695 3 -1214 311 1756 1447 3 -612 1949 991 779 3 -820 949 1604 938 3 -610 1452 1552 1547 3 -1391 1059 956 1325 3 -697 1675 1020 1153 3 -1627 573 670 1035 3 -1249 1098 51 748 3 -53 639 592 1422 3 -399 131 1567 398 3 -1140 517 1410 123 3 -1377 1644 1794 1625 3 -844 1440 1612 174 3 -1712 1023 951 1298 3 -1090 1701 1722 618 3 -1085 676 635 1129 3 -86 278 520 128 3 -724 481 907 791 3 -1843 1635 565 1773 3 -1564 1202 1378 602 3 -679 1197 894 939 3 -938 949 893 787 3 -1127 814 1573 276 3 -1625 1834 1804 1314 3 -1359 1365 555 579 3 -1422 1085 635 1129 3 -1302 236 911 1571 3 -16 1023 1474 1712 3 -1059 1185 1212 1325 3 -476 690 746 945 3 -1245 415 1381 840 3 -745 945 65 927 3 -258 1321 67 363 3 -793 600 1546 3 3 -1320 942 1592 881 3 -306 931 1783 1374 3 -681 656 1137 806 3 -1648 1508 341 1716 3 -1154 1525 1103 550 3 -633 1178 671 1732 3 -1051 841 1514 1403 3 -809 1558 187 960 3 -1299 1066 1797 1802 3 -1036 983 60 677 3 -414 1199 1046 1630 3 -1215 1880 1940 954 3 -705 1417 583 1298 3 -118 966 677 777 3 -1392 431 796 614 3 -118 355 777 1485 3 -118 386 966 355 3 -463 1724 1039 460 3 -1559 692 1126 915 3 -1117 1319 1224 1626 3 -1571 668 1797 1483 3 -812 1483 373 668 3 -1225 403 347 864 3 -1564 1184 1528 1202 3 -1581 871 1122 188 3 -1409 671 1748 1245 3 -443 1177 1300 924 3 -1564 540 999 1928 3 -354 876 1513 1883 3 -1660 1883 1488 585 3 -1436 897 1723 1342 3 -1909 12 1699 1729 3 -43 190 1247 883 3 -1261 1107 1283 1860 3 -1666 1841 1471 1655 3 -103 376 1003 404 3 -142 404 1379 1799 3 -1403 1266 597 976 3 -1238 8 1335 1926 3 -1574 1403 952 1155 3 -675 1567 1554 294 3 -1563 1551 1007 289 3 -1845 1748 1859 1346 3 -57 940 508 589 3 -1854 1282 1556 1649 3 -1788 944 1364 1506 3 -69 334 1006 161 3 -1593 141 1545 100 3 -478 878 1286 1411 3 -1729 1505 438 1331 3 -1668 1715 935 1062 3 -1774 1576 1234 1350 3 -1940 1880 298 1043 3 -94 247 95 1529 3 -608 934 795 1337 3 -763 981 1703 471 3 -334 101 66 1593 3 -1178 633 671 1346 3 -162 173 1518 529 3 -1842 1280 1939 801 3 -1937 1764 1307 1564 3 -1245 550 1740 1743 3 -524 847 1349 97 3 -774 1008 1745 541 3 -728 1392 976 650 3 -1895 465 1269 1309 3 -946 1177 924 1733 3 -1843 1773 565 669 3 -1845 1322 1251 1630 3 -1657 1344 369 1782 3 -1954 1356 575 1674 3 -1724 460 355 1498 3 -720 409 1311 152 3 -549 894 1060 457 3 -1344 1812 389 340 3 -722 852 971 1146 3 -1328 1549 522 621 3 -1484 1744 1546 600 3 -793 1575 1421 1405 3 -55 230 511 1256 3 -982 1639 1101 952 3 -1950 1132 1955 1135 3 -391 1355 1269 817 3 -674 1799 421 1318 3 -1654 1082 1219 1150 3 -920 1514 1392 1051 3 -678 1092 669 941 3 -534 852 1867 1537 3 -418 98 75 295 3 -418 98 295 480 3 -867 1472 965 1652 3 -1610 1853 463 1815 3 -899 963 828 633 3 -1945 1605 1507 1130 3 -633 963 828 667 3 -65 632 927 1595 3 -436 904 487 591 3 -1802 514 208 557 3 -1462 1802 804 1205 3 -1483 1622 514 1654 3 -291 1091 292 670 3 -1357 981 1203 933 3 -1037 1307 1528 1937 3 -963 672 760 666 3 -1493 1419 470 1615 3 -1544 1720 1780 1090 3 -944 554 803 863 3 -1475 1308 546 1113 3 -1239 1013 1104 1809 3 -1803 443 1770 1426 3 -1474 1023 951 1712 3 -343 449 1416 1885 3 -746 945 1702 553 3 -375 1013 1305 316 3 -544 893 1148 1800 3 -921 581 1207 1829 3 -1864 1348 335 1534 3 -53 1333 1422 592 3 -1207 1453 1689 1194 3 -1400 1337 1434 316 3 -1386 1258 337 1300 3 -182 574 642 925 3 -606 1428 1753 1779 3 -1536 1210 1031 1378 3 -1721 560 1823 954 3 -424 708 361 1811 3 -1933 1698 1786 1780 3 -43 725 192 1800 3 -1322 1630 427 1251 3 -678 669 1132 941 3 -738 1060 629 36 3 -501 1019 783 1393 3 -1393 1562 783 501 3 -1098 386 1632 1190 3 -698 594 1238 462 3 -510 1512 1362 1602 3 -793 1421 600 1413 3 -921 1829 487 1370 3 -910 861 708 20 3 -894 1816 416 679 3 -753 1705 1188 607 3 -1184 987 1896 1421 3 -1276 495 819 1618 3 -1390 488 757 1387 3 -1719 1036 619 491 3 -1607 656 1876 1279 3 -413 128 829 38 3 -138 634 1165 1293 3 -823 715 1819 623 3 -328 1730 1920 1568 3 -1021 673 1661 676 3 -278 245 1609 200 3 -437 459 1887 432 3 -237 1302 1220 1489 3 -1275 326 440 325 3 -385 1347 1767 159 3 -1848 1791 913 1081 3 -934 753 795 1337 3 -400 1141 1931 558 3 -622 1934 120 1304 3 -513 103 1003 1914 3 -511 646 55 475 3 -748 1190 1632 1708 3 -1286 752 624 975 3 -562 46 1588 144 3 -473 400 1931 558 3 -504 49 1593 691 3 -802 1881 1294 587 3 -27 188 1311 1624 3 -1201 1661 676 1021 3 -738 629 1057 787 3 -908 1839 56 1081 3 -973 1334 315 903 3 -376 972 374 792 3 -1743 974 165 177 3 -1249 1055 1913 1388 3 -1732 1736 1154 671 3 -451 1335 468 1926 3 -894 1321 549 707 3 -723 969 1956 1578 3 -736 790 170 1588 3 -1200 1702 132 661 3 -1317 926 413 678 3 -903 1586 1631 175 3 -1400 49 375 1013 3 -1825 1954 1385 1831 3 -483 1710 1297 1777 3 -1306 1474 16 1023 3 -472 1194 1851 1765 3 -758 1182 967 723 3 -1054 1765 809 382 3 -388 1932 1651 336 3 -1091 842 939 679 3 -508 258 1321 67 3 -1317 38 413 926 3 -1832 461 1902 1160 3 -1282 964 1039 1531 3 -1786 1090 655 1933 3 -482 103 513 609 3 -1271 6 923 314 3 -1255 1338 1834 1314 3 -932 1693 1096 682 3 -1227 734 1776 851 3 -1317 413 562 678 3 -926 413 786 829 3 -1595 1380 65 943 3 -1147 1640 1535 583 3 -1274 1939 1079 752 3 -343 1416 759 1069 3 -1877 1231 1942 1093 3 -1321 508 707 1058 3 -248 206 1015 78 3 -704 1754 660 1532 3 -570 12 1699 1909 3 -1035 1091 670 1627 3 -1910 1280 801 1500 3 -1810 1325 1391 909 3 -1391 1433 1810 71 3 -1811 1688 424 861 3 -1217 573 1255 18 3 -606 1779 1753 1149 3 -603 1608 1297 1681 3 -1552 874 610 1784 3 -560 1609 19 520 3 -1054 1097 1516 1851 3 -1137 1313 806 1279 3 -1782 1347 1121 914 3 -1876 488 502 1357 3 -1841 1596 1655 351 3 -495 1045 440 1037 3 -967 380 381 870 3 -1541 682 1096 179 3 -1235 890 854 643 3 -109 596 1520 485 3 -1540 1779 1773 1823 3 -677 1741 1667 1838 3 -119 1560 319 1885 3 -548 1260 1732 858 3 -1350 428 1492 1606 3 -887 1611 1838 639 3 -763 471 696 1340 3 -1437 906 1694 956 3 -763 1340 696 1906 3 -1336 1208 487 378 3 -303 1571 557 236 3 -100 1593 516 512 3 -564 41 299 229 3 -495 977 497 1618 3 -956 1059 494 1212 3 -467 637 1441 82 3 -1276 1030 898 819 3 -1013 1400 316 375 3 -1274 975 752 1079 3 -1781 1235 693 687 3 -1371 1011 393 875 3 -1392 788 976 650 3 -532 16 1093 1712 3 -662 795 537 1177 3 -621 1805 1549 19 3 -991 662 1177 612 3 -991 662 537 1177 3 -436 1097 1727 1671 3 -1863 491 42 802 3 -1374 1534 282 335 3 -840 1486 406 1585 3 -887 1650 1656 1424 3 -1520 1232 218 300 3 -1122 25 1120 1179 3 -1718 1384 1536 738 3 -110 40 1219 291 3 -138 402 96 598 3 -856 1465 716 581 3 -1247 1718 1375 36 3 -349 584 1733 176 3 -1227 362 1533 734 3 -518 77 293 1876 3 -528 516 161 1272 3 -604 1224 1626 1785 3 -402 371 96 598 3 -542 741 1281 511 3 -1581 1867 1157 1122 3 -1290 1105 1128 412 3 -1461 1603 782 366 3 -871 187 1194 25 3 -928 1947 1498 1584 3 -1290 1062 1105 412 3 -1173 1449 1262 1550 3 -1565 819 33 1399 3 -1690 1096 160 435 3 -970 464 1645 1468 3 -838 73 493 1195 3 -590 322 1891 470 3 -1702 745 496 945 3 -475 941 1132 1412 3 -1871 741 685 581 3 -467 398 1441 637 3 -979 1605 1448 1379 3 -1021 854 890 1007 3 -1847 1787 354 1751 3 -1697 1640 730 1535 3 -690 945 1085 984 3 -1217 1754 833 406 3 -1379 405 799 1414 3 -1627 1754 1532 1255 3 -1563 289 1007 201 3 -1427 58 1559 692 3 -1434 607 1327 1188 3 -598 652 509 1164 3 -776 1024 1209 366 3 -971 124 1877 1231 3 -1520 936 1232 300 3 -1805 888 1234 1435 3 -1561 565 1350 1431 3 -868 1740 912 500 3 -536 1230 1253 732 3 -1003 376 799 404 3 -1451 273 274 1166 3 -1805 1244 1707 1670 3 -322 492 1419 590 3 -231 1806 289 1808 3 -1384 1804 1704 1338 3 -28 87 1807 1022 3 -888 1350 1234 1435 3 -470 1419 590 322 3 -968 1910 434 215 3 -1007 201 931 865 3 -890 1007 931 865 3 -1630 878 1817 1011 3 -987 980 1184 1896 3 -1859 247 1679 434 3 -434 1910 1755 215 3 -748 51 1027 178 3 -1199 636 1019 350 3 -82 1385 1052 1265 3 -1585 1682 1681 1834 3 -894 755 1450 416 3 -531 543 917 22 3 -1085 1751 784 984 3 -1069 781 1025 587 3 -1069 781 645 1025 3 -494 452 1059 1121 3 -1255 1816 406 1834 3 -1802 1462 1718 1622 3 -802 754 781 1009 3 -362 93 157 1227 3 -1227 794 157 362 3 -1541 1749 777 150 3 -245 313 1328 314 3 -475 1132 916 1412 3 -491 1741 677 966 3 -1013 1925 1809 1034 3 -261 1022 1043 214 3 -1613 730 1288 1306 3 -1599 1455 1262 1775 3 -406 1486 1562 1585 3 -1732 1736 899 1770 3 -260 1817 1402 136 3 -540 999 1928 22 3 -1615 1419 1368 1193 3 -1366 1930 784 989 3 -1503 1666 335 1745 3 -1481 1635 383 653 3 -928 1708 748 1610 3 -1871 286 685 741 3 -575 1568 959 1946 3 -167 620 1240 186 3 -943 1105 1128 1290 3 -673 653 1661 1129 3 -1608 1710 1297 483 3 -63 564 541 267 3 -1698 1070 1174 1078 3 -647 1385 1825 1946 3 -1640 1223 827 45 3 -1323 635 1095 686 3 -400 420 379 558 3 -706 1819 623 823 3 -1691 1832 1160 461 3 -965 1270 1038 1362 3 -400 420 558 473 3 -1326 697 134 1020 3 -615 1087 1801 620 3 -1274 238 975 1079 3 -1381 1154 1469 1525 3 -1727 1216 846 534 3 -1581 1867 852 1157 3 -1175 1362 1270 965 3 -1423 863 1777 644 3 -1700 1701 1550 1332 3 -1333 984 592 953 3 -1947 1039 1498 460 3 -351 1596 1655 1819 3 -815 1542 783 1019 3 -1163 707 526 880 3 -1816 49 416 679 3 -1618 325 440 977 3 -1326 697 32 134 3 -1145 981 763 933 3 -1949 1177 991 1300 3 -1741 677 966 777 3 -945 1751 65 1847 3 -278 1000 288 1772 3 -67 526 221 309 3 -288 1020 134 255 3 -809 1862 1194 1558 3 -1879 482 498 611 3 -1289 615 1801 620 3 -503 1200 661 289 3 -585 1847 354 1751 3 -1218 1373 1368 1600 3 -1350 1109 1606 1530 3 -1292 1476 126 611 3 -1936 24 798 1315 3 -585 1522 1660 1778 3 -64 988 1032 74 3 -191 917 544 725 3 -1198 170 736 52 3 -1530 1350 1774 888 3 -448 1412 477 1766 3 -240 1634 272 1924 3 -1839 56 1752 908 3 -1421 1629 1528 618 3 -1023 1037 1474 1320 3 -612 912 1352 605 3 -1695 570 652 1531 3 -1441 1394 577 647 3 -1729 1505 1331 5 3 -350 1763 866 1860 3 -564 685 265 541 3 -951 1720 1814 1544 3 -1930 1431 989 1370 3 -1536 938 1704 1377 3 -1346 684 1139 1679 3 -82 1052 1441 1265 3 -1024 1107 652 1695 3 -381 870 841 895 3 -882 1089 1490 1530 3 -1902 433 744 1160 3 -74 64 1891 1493 3 -1777 863 1038 644 3 -37 463 1815 178 3 -183 868 48 210 3 -151 1383 34 1873 3 -1005 1691 976 1673 3 -944 863 803 586 3 -346 323 324 631 3 -153 718 732 535 3 -209 976 1278 1691 3 -336 615 1651 826 3 -1209 1261 1199 782 3 -577 837 1578 647 3 -327 384 116 1892 3 -1794 1644 1068 1625 3 -732 720 152 718 3 -523 1855 1735 1026 3 -559 926 475 646 3 -1289 1688 1031 861 3 -1937 1528 1592 1202 3 -1079 246 752 21 3 -385 1121 370 1347 3 -412 1128 1731 1852 3 -969 1559 571 58 3 -717 815 1817 1542 3 -1422 1333 984 592 3 -475 916 1132 1360 3 -707 1060 36 629 3 -1575 919 980 1363 3 -328 1730 327 1920 3 -383 1753 1248 1773 3 -711 1035 670 573 3 -1247 1462 190 917 3 -915 1279 1136 510 3 -1070 1218 1583 1524 3 -1022 1807 1043 1171 3 -1614 1488 1883 23 3 -793 866 3 1546 3 -1068 1921 1445 1393 3 -1217 801 660 1274 3 -325 977 1410 1415 3 -312 814 1127 242 3 -1224 1319 279 721 3 -1772 1927 1063 200 3 -491 1881 1560 1294 3 -707 894 1058 1060 3 -252 823 159 1819 3 -1387 900 1425 577 3 -1250 79 935 1295 3 -887 1838 1837 1635 3 -1132 1753 678 1955 3 -163 172 1870 702 3 -260 717 1817 136 3 -707 1058 36 1060 3 -1188 753 1327 642 3 -801 660 833 1217 3 -654 1371 1011 394 3 -256 865 1083 687 3 -57 110 940 589 3 -1859 1280 1755 1910 3 -790 1084 606 52 3 -341 1010 1191 740 3 -154 709 361 424 3 -476 676 1085 553 3 -1257 1254 854 1366 3 -1151 608 1400 1922 3 -940 1058 486 36 3 -850 1358 474 866 3 -1147 1285 1535 389 3 -1181 1248 1779 1773 3 -53 1333 1323 1422 3 -414 551 1659 1750 3 -964 360 932 1039 3 -620 1087 785 186 3 -1110 1092 786 941 3 -1226 876 1561 639 3 -580 1324 1403 597 3 -1124 1324 855 1548 3 -551 666 667 1936 3 -1626 937 1041 572 3 -1358 712 474 866 3 -1925 695 908 860 3 -359 1498 355 1725 3 -1814 1597 881 1780 3 -930 1750 1261 1283 3 -745 496 1026 959 3 -1477 1695 1531 1821 3 -1910 1859 947 434 3 -49 1754 1593 512 3 -1916 1734 1907 768 3 -407 1287 1312 561 3 -1279 789 1126 728 3 -1728 959 1855 1946 3 -198 611 1228 1555 3 -1057 1432 1136 1176 3 -1827 1915 625 873 3 -1598 1556 672 1260 3 -576 861 910 1299 3 -1797 1299 576 910 3 -876 1747 23 1332 3 -135 1568 737 1893 3 -865 553 1893 1781 3 -1843 477 1766 1930 3 -1691 193 1080 1152 3 -1567 1145 577 1554 3 -977 505 1045 495 3 -735 173 791 1242 3 -824 1187 1690 1361 3 -882 1164 509 1490 3 -1163 681 880 309 3 -1227 93 813 1652 3 -1262 1636 1775 1515 3 -1512 948 1710 1427 3 -1895 1358 850 1309 3 -1227 1652 813 867 3 -312 814 880 1278 3 -560 261 522 1609 3 -1045 505 1037 495 3 -181 70 700 889 3 -857 363 1163 1321 3 -647 1946 1825 571 3 -1047 1721 1823 954 3 -1193 1055 754 1615 3 -1798 358 1527 1904 3 -1788 586 944 1506 3 -1549 560 522 19 3 -1045 1288 1857 1330 3 -1400 1337 316 375 3 -1798 171 1904 163 3 -490 1193 754 1373 3 -377 1241 881 1233 3 -1793 1291 921 487 3 -1023 730 583 1161 3 -191 43 917 725 3 -1956 969 1946 1578 3 -230 541 511 1686 3 -1441 1578 723 1956 3 -705 1298 1143 1417 3 -1497 192 158 221 3 -1207 581 921 716 3 -1092 1884 1110 786 3 -181 70 889 183 3 -415 1381 1709 39 3 -1352 912 779 164 3 -873 225 1915 264 3 -1305 1467 418 310 3 -908 1034 1354 1809 3 -1306 805 835 1629 3 -1168 665 1436 1342 3 -1338 457 1398 1060 3 -1570 1244 872 1291 3 -1326 1153 697 1020 3 -1551 231 1806 289 3 -549 894 707 1060 3 -1325 58 1639 1559 3 -1828 1424 1600 428 3 -68 657 1456 991 3 -297 1372 1454 1303 3 -1415 326 977 1140 3 -1931 1141 1616 558 3 -1072 1039 463 360 3 -814 656 806 1573 3 -1191 816 1138 572 3 -1217 1519 801 1274 3 -398 1441 577 1425 3 -1367 1830 752 1480 3 -1089 601 1636 1515 3 -758 723 58 1325 3 -1946 1385 1825 959 3 -827 1223 1433 1030 3 -631 835 1093 16 3 -1208 1291 1793 487 3 -171 52 1870 172 3 -89 1955 1950 559 3 -348 1073 35 1094 3 -751 1100 1318 184 3 -313 1271 1836 1328 3 -249 98 1305 480 3 -548 1154 1732 1088 3 -1722 618 600 1484 3 -1032 449 1263 781 3 -1870 52 606 172 3 -375 608 1685 1400 3 -403 1062 1105 1106 3 -68 1949 1259 779 3 -490 1055 754 1193 3 -1615 1193 1055 1419 3 -1136 1176 1512 811 3 -1134 545 1368 1504 3 -1549 1043 522 560 3 -322 1406 387 470 3 -1128 1731 813 1506 3 -493 929 1015 206 3 -1242 1865 635 493 3 -631 730 1613 835 3 -562 678 520 1540 3 -1192 864 1472 1105 3 -608 375 1685 1642 3 -1574 1403 841 147 3 -1328 217 245 522 3 -557 514 208 869 3 -1817 1616 1402 136 3 -1211 379 1941 558 3 -1888 1761 296 205 3 -74 1440 1032 1493 3 -1827 225 1915 873 3 -241 1222 990 1447 3 -1002 904 591 989 3 -1718 738 1375 36 3 -989 904 487 1040 3 -1722 618 1672 600 3 -398 1425 577 1567 3 -1747 1722 986 655 3 -542 1281 1326 786 3 -1771 211 382 1666 3 -1754 1685 833 406 3 -671 633 1139 1346 3 -825 225 713 1915 3 -119 333 481 907 3 -740 1455 1775 1547 3 -1550 904 1332 1173 3 -354 1787 592 1751 3 -452 1875 446 1657 3 -119 907 1560 1885 3 -448 1661 477 1412 3 -862 299 233 564 3 -135 1893 737 1397 3 -151 330 1844 998 3 -1602 948 1512 1362 3 -887 639 1635 1561 3 -94 1830 247 1529 3 -1323 686 791 1242 3 -18 651 641 1491 3 -1336 1793 17 487 3 -1829 541 1745 1008 3 -440 742 1288 1330 3 -524 818 1349 847 3 -452 1957 1875 1657 3 -1824 1488 1720 1332 3 -340 1186 1899 834 3 -1089 601 1840 1636 3 -324 1663 1872 835 3 -1875 962 446 1657 3 -1354 1313 1137 1502 3 -760 1853 563 1538 3 -731 1426 1193 879 3 -587 781 802 1881 3 -1691 1160 1832 1080 3 -286 856 1125 741 3 -577 692 1511 981 3 -286 1125 287 741 3 -1491 1196 1314 373 3 -445 79 561 645 3 -1781 890 1050 1235 3 -550 1525 1103 612 3 -1892 116 489 384 3 -381 380 1048 1390 3 -601 1515 1452 610 3 -230 685 511 541 3 -1204 408 407 1312 3 -1458 509 1164 617 3 -627 413 562 1317 3 -906 76 1464 845 3 -1361 179 1903 688 3 -918 568 45 1276 3 -560 1171 954 1043 3 -1312 1826 1889 408 3 -1171 214 144 170 3 -214 1022 1171 144 3 -560 1171 567 954 3 -560 562 567 1171 3 -1448 1799 1945 674 3 -1678 768 1154 1088 3 -1946 1694 1212 969 3 -411 1363 410 1861 3 -1932 807 1330 1764 3 -565 1226 1561 1635 3 -1060 1058 36 1384 3 -548 1732 1154 1178 3 -1071 595 250 361 3 -1813 1678 1445 1463 3 -1516 733 1869 871 3 -871 1122 1194 1867 3 -1860 1953 703 817 3 -1254 1745 774 1008 3 -540 543 1028 1073 3 -903 944 973 586 3 -1763 850 636 866 3 -1741 1584 42 1650 3 -1854 1649 1556 1658 3 -1389 1760 588 1612 3 -1655 1819 1789 623 3 -531 576 22 1462 3 -623 1671 1503 1004 3 -921 1829 1370 648 3 -1394 1886 864 1443 3 -1362 1839 696 471 3 -1860 1687 817 1759 3 -727 640 889 934 3 -640 739 70 889 3 -1449 1570 1040 1431 3 -1361 1903 1940 688 3 -544 725 1800 1832 3 -1366 44 1254 854 3 -1570 565 1431 1435 3 -442 357 1760 1499 3 -1441 1052 647 1265 3 -517 999 1073 348 3 -69 640 1006 334 3 -664 1361 1444 824 3 -893 738 938 787 3 -1502 1136 811 1057 3 -965 867 1776 1038 3 -22 738 938 893 3 -1458 882 874 601 3 -1471 1666 1503 1054 3 -602 1644 1031 1495 3 -1502 1602 1512 510 3 -1656 42 1373 1650 3 -1437 1956 909 1694 3 -1200 746 1702 553 3 -872 1449 1898 1455 3 -746 397 1951 364 3 -1610 1708 748 1815 3 -1689 716 761 766 3 -1268 1492 428 1606 3 -879 1556 928 1598 3 -1333 690 1085 984 3 -1255 406 1217 18 3 -1027 1815 748 178 3 -1437 1956 1182 909 3 -1277 178 1027 1738 3 -1508 472 901 1537 3 -1010 1252 536 816 3 -679 416 894 1197 3 -1901 1264 972 484 3 -1622 1384 1536 1718 3 -1922 457 1398 755 3 -740 1547 1775 816 3 -664 1361 824 897 3 -1145 1443 1886 577 3 -493 1195 929 206 3 -1332 904 1700 1720 3 -104 1616 810 1442 3 -1147 389 1535 1099 3 -930 1695 1024 1477 3 -1171 1383 567 954 3 -778 570 1821 1531 3 -1732 1770 899 1260 3 -1652 1105 1472 425 3 -1393 1628 1463 782 3 -663 308 756 1274 3 -311 81 1214 860 3 -1710 764 1213 1777 3 -632 1954 1831 955 3 -785 1688 1289 861 3 -550 1103 1154 1245 3 -676 476 1200 553 3 -1438 601 1636 1953 3 -557 1150 869 283 3 -1226 1635 565 1843 3 -1320 626 33 1565 3 -1652 425 92 93 3 -1438 1953 1636 1355 3 -507 1068 1393 1664 3 -1724 359 1039 1498 3 -1631 176 839 515 3 -1368 545 1218 1504 3 -407 1204 364 408 3 -1355 1438 1953 1476 3 -520 19 786 1000 3 -669 1843 1370 1570 3 -1814 1597 1780 1698 3 -1214 81 1166 860 3 -1342 897 1723 11 3 -1419 1055 492 1193 3 -64 1769 754 988 3 -364 1951 892 1123 3 -1203 1357 933 293 3 -888 1774 886 1234 3 -1212 956 772 494 3 -1792 1529 414 1845 3 -1014 1487 1016 1211 3 -1107 703 1860 1953 3 -1278 650 976 788 3 -1848 877 1167 1451 3 -1434 555 1776 365 3 -450 760 419 1395 3 -381 506 1101 344 3 -381 506 895 1101 3 -938 1057 820 1432 3 -841 1580 1101 1574 3 -149 69 762 640 3 -665 277 227 1836 3 -928 1854 1556 1658 3 -1899 971 1812 834 3 -1379 142 1799 751 3 -902 1836 277 665 3 -1657 1344 444 369 3 -1855 1735 1847 585 3 -1070 1795 1170 1710 3 -53 1333 592 953 3 -639 53 1611 1470 3 -1623 975 1220 1408 3 -751 536 352 1100 3 -424 708 1811 861 3 -879 928 1193 1598 3 -1197 679 691 939 3 -1514 728 1155 1126 3 -809 960 1929 382 3 -1669 533 1838 1837 3 -375 607 1337 316 3 -43 917 1800 1247 3 -1667 533 832 1560 3 -1730 1464 1694 1946 3 -1010 1648 1216 1599 3 -9 1552 886 1805 3 -1326 542 32 1125 3 -1639 506 895 758 3 -928 748 1708 1190 3 -422 421 1507 1130 3 -1913 1692 731 1598 3 -1619 1720 1700 904 3 -368 798 1653 1659 3 -1382 1042 532 1619 3 -104 1442 810 1638 3 -1103 795 946 39 3 -789 1392 1514 728 3 -605 795 662 1103 3 -176 584 1733 1334 3 -612 662 1177 1103 3 -759 1826 616 1621 3 -1107 1164 703 1953 3 -1535 730 1161 583 3 -1305 98 418 480 3 -1753 995 1248 1428 3 -886 1444 1805 1234 3 -1752 1362 696 555 3 -188 871 852 1581 3 -886 1444 1549 1805 3 -1034 1888 458 1061 3 -751 142 1318 1100 3 -451 422 331 1430 3 -1076 1130 1414 1926 3 -1320 495 1565 1023 3 -1258 1300 991 1733 3 -1283 1860 1763 350 3 -1857 747 1330 742 3 -395 1606 428 1260 3 -334 101 1593 516 3 -625 1129 1015 676 3 -345 1181 1779 1773 3 -1872 1130 1076 1926 3 -1671 591 436 1478 3 -1848 814 1167 877 3 -609 1396 1905 482 3 -928 1708 1039 1947 3 -1366 1002 784 1846 3 -1670 1707 1805 19 3 -1586 794 362 1074 3 -297 1372 210 1454 3 -348 999 1339 531 3 -9 665 923 1328 3 -191 917 543 544 3 -1828 1088 1600 768 3 -772 1212 1855 489 3 -470 1677 588 1820 3 -1173 1550 1747 1332 3 -1282 776 1649 14 3 -1570 872 1244 1435 3 -1257 591 1254 1366 3 -1349 435 780 897 3 -1872 1076 1430 835 3 -1864 1666 1771 335 3 -1745 1004 1503 1478 3 -693 737 1892 523 3 -1525 924 443 1582 3 -769 1520 1115 1874 3 -609 1396 1316 1905 3 -138 634 1293 617 3 -237 1302 1489 281 3 -1795 1213 1270 948 3 -1190 928 748 42 3 -683 835 1076 1629 3 -1115 13 1874 1520 3 -1521 1009 701 1504 3 -255 108 13 1115 3 -134 108 255 1115 3 -985 1619 904 1720 3 -109 108 1115 13 3 -109 108 766 1115 3 -134 108 1115 697 3 -1020 1115 134 255 3 -1633 1065 262 1168 3 -602 1068 1378 1644 3 -1115 766 485 1020 3 -697 766 1115 1020 3 -292 1091 62 691 3 -697 108 1115 766 3 -1020 697 134 1115 3 -1102 594 1238 8 3 -1015 1189 493 1129 3 -1953 1438 601 1482 3 -339 1683 891 1324 3 -943 867 1364 1128 3 -1943 539 1093 659 3 -1265 1674 845 1952 3 -1932 1764 1564 1801 3 -1057 629 1313 787 3 -1057 1313 629 1060 3 -1840 601 1953 1636 3 -12 1283 1699 1729 3 -1057 1313 1136 787 3 -1462 576 22 1622 3 -973 315 1820 903 3 -1622 1031 22 1536 3 -586 1334 973 903 3 -870 1425 58 723 3 -1603 776 1606 1260 3 -1291 1557 1675 1742 3 -537 925 853 642 3 -1137 1313 1279 1136 3 -598 1953 1164 1158 3 -1840 1107 1860 1953 3 -1840 1107 1953 1164 3 -1158 598 1077 138 3 -1864 211 1771 1666 3 -581 41 564 1871 3 -785 861 709 424 3 -1524 1504 554 803 3 -838 529 1242 493 3 -1764 1932 423 1801 3 -1067 1122 1689 1120 3 -1187 179 1938 1361 3 -424 709 708 861 3 -1595 1954 1825 1831 3 -1844 1198 1301 1428 3 -1905 1138 352 536 3 -598 817 1158 426 3 -699 122 539 1877 3 -1547 1452 1552 1455 3 -524 964 1693 160 3 -1134 470 588 973 3 -1938 1903 1096 435 3 -1630 1322 815 478 3 -1484 1528 1544 525 3 -1364 1731 1128 1506 3 -1436 922 664 897 3 -1033 1522 1559 1814 3 -1939 308 663 1274 3 -1125 106 697 716 3 -32 130 697 1125 3 -966 1498 777 355 3 -719 766 771 109 3 -1753 606 1149 1955 3 -60 171 1904 1798 3 -334 889 1006 161 3 -1897 1519 1562 783 3 -1245 1381 556 840 3 -1051 841 920 1514 3 -60 171 1844 1904 3 -1379 405 1414 1945 3 -1250 1295 935 83 3 -1658 1649 1556 1109 3 -1710 811 1662 603 3 -1844 330 521 998 3 -874 689 1723 1458 3 -1598 1770 731 879 3 -867 1652 965 1227 3 -912 1711 353 974 3 -1729 703 438 1505 3 -1775 1515 1455 1262 3 -1759 1505 1309 884 3 -1152 193 192 61 3 -1440 1156 1056 1032 3 -788 650 1279 806 3 -474 866 3 793 3 -950 1867 1851 1097 3 -1386 991 1258 1300 3 -536 830 1253 1138 3 -1131 382 233 862 3 -1603 1628 1268 1594 3 -1487 1911 1941 379 3 -862 564 233 1131 3 -1706 1810 59 71 3 -1348 1503 335 1235 3 -1391 1437 1696 909 3 -732 718 7 1253 3 -949 1928 22 540 3 -1618 455 1086 1276 3 -1928 1031 1289 1378 3 -1718 1622 22 1536 3 -1581 871 852 1867 3 -488 77 920 1876 3 -249 310 1305 75 3 -872 1244 714 1291 3 -1581 188 1122 1179 3 -1692 1027 672 1598 3 -897 780 11 922 3 -1306 1629 835 16 3 -655 1722 1461 1744 3 -1252 751 513 1379 3 -828 671 974 1887 3 -812 651 1220 1623 3 -1707 1540 1823 19 3 -1206 847 524 97 3 -1042 582 1619 1382 3 -1915 225 713 231 3 -556 1678 1154 548 3 -505 1764 1937 1564 3 -1028 893 787 1148 3 -280 775 1408 204 3 -714 1244 1746 1291 3 -1663 859 15 1613 3 -919 1861 154 424 3 -311 1214 695 860 3 -392 1476 1355 391 3 -1167 309 681 1163 3 -1839 1362 696 1752 3 -152 189 1429 7 3 -181 889 1352 183 3 -1448 1605 1672 1507 3 -1782 1347 914 715 3 -921 716 1281 1153 3 -1665 1474 1544 1528 3 -930 1315 1283 1695 3 -153 699 1267 1146 3 -1129 1422 1865 635 3 -517 977 1410 1882 3 -902 277 1459 1436 3 -977 1894 1410 1882 3 -445 645 342 1416 3 -343 445 342 1416 3 -1163 857 1321 681 3 -871 187 1869 809 3 -1525 1711 550 1736 3 -965 1227 1906 734 3 -1224 726 822 604 3 -633 667 828 1139 3 -517 1714 977 1882 3 -511 1281 926 941 3 -1363 423 410 1861 3 -658 66 98 504 3 -683 1507 1943 1142 3 -823 1347 159 715 3 -1014 1487 1211 411 3 -977 1714 1894 1882 3 -1701 683 1672 618 3 -930 1283 1261 1695 3 -290 1702 1568 1893 3 -914 452 494 1121 3 -325 977 1894 1410 3 -511 542 926 1281 3 -1013 49 504 416 3 -1696 967 506 758 3 -338 1424 1757 1492 3 -1350 986 1492 338 3 -655 1090 23 1747 3 -1086 1276 898 819 3 -1814 1233 1597 1698 3 -1484 1921 1933 1665 3 -937 816 1547 740 3 -1766 44 1008 1366 3 -1308 631 1093 16 3 -771 766 485 109 3 -1832 1028 461 650 3 -23 1090 655 1786 3 -941 1766 1110 669 3 -566 837 1192 647 3 -899 1501 1692 1770 3 -897 664 1940 922 3 -1553 608 727 415 3 -1794 1202 820 1172 3 -1603 1209 1463 782 3 -1453 107 1689 1862 3 -1864 335 282 1534 3 -53 1669 1470 832 3 -103 102 1396 482 3 -1313 787 1148 1136 3 -715 914 1789 623 3 -1924 913 1340 770 3 -1153 1742 1020 786 3 -520 1092 19 1540 3 -520 1092 1540 678 3 -1495 1542 812 1457 3 -1742 1557 1675 485 3 -1433 1143 1417 452 3 -1553 1754 1685 833 3 -1148 787 650 1136 3 -1639 758 895 58 3 -442 1250 1389 1715 3 -1287 1295 1617 645 3 -86 28 520 278 3 -977 1330 440 1045 3 -1625 1804 1210 1314 3 -111 110 40 1219 3 -61 209 1278 1691 3 -1525 1469 39 946 3 -1510 93 362 1227 3 -30 1944 1640 568 3 -981 1511 510 692 3 -188 1179 152 189 3 -1842 1280 1910 215 3 -1649 1576 1187 14 3 -664 824 1444 479 3 -296 939 137 1761 3 -461 433 1548 1902 3 -1102 1569 1405 1238 3 -56 1602 1839 1752 3 -599 1225 637 1052 3 -1300 1733 973 924 3 -151 1301 998 1844 3 -231 713 1806 306 3 -760 750 450 563 3 -1950 304 222 1360 3 -429 1796 1890 401 3 -1313 1148 1279 1136 3 -1379 1799 1448 751 3 -1781 1397 737 1893 3 -381 380 1390 870 3 -1908 104 10 1442 3 -1636 1775 979 1672 3 -115 380 114 1390 3 -1657 369 446 1782 3 -1581 1179 152 188 3 -642 1376 853 1423 3 -735 1758 686 148 3 -505 540 626 1714 3 -805 1076 835 1629 3 -611 1523 1476 1555 3 -1525 924 1177 443 3 -1806 1007 289 201 3 -210 1372 1590 1454 3 -1103 1740 612 605 3 -542 1281 1125 1326 3 -122 346 324 1942 3 -539 1507 1943 1430 3 -597 1155 1620 952 3 -1581 1179 1157 152 3 -1572 975 651 1274 3 -771 1067 155 109 3 -1894 325 329 1618 3 -1312 561 645 342 3 -1170 1380 566 1795 3 -1536 938 738 1704 3 -1003 799 979 1379 3 -1211 810 919 595 3 -1743 671 974 947 3 -1038 867 1788 1737 3 -769 923 1117 439 3 -1161 583 1023 1298 3 -326 1330 440 977 3 -325 326 977 1415 3 -1867 871 1122 1581 3 -668 576 1797 1483 3 -483 1709 1681 1381 3 -1758 173 1242 838 3 -1814 1033 951 377 3 -1328 217 313 245 3 -1507 749 539 1142 3 -1034 458 857 363 3 -1560 533 907 1900 3 -453 1238 423 462 3 -1747 1262 986 1722 3 -471 1511 1175 1362 3 -580 194 196 1266 3 -196 194 1005 1266 3 -230 978 253 646 3 -1175 1270 867 965 3 -95 247 145 1679 3 -604 726 992 1224 3 -226 279 1012 1224 3 -1507 1130 1076 1430 3 -1266 194 1005 976 3 -580 1266 196 597 3 -1029 1448 1142 1507 3 -1654 1150 1219 486 3 -560 261 1043 522 3 -1705 149 607 739 3 -1585 1625 1681 1445 3 -1943 1216 1712 683 3 -938 1057 738 1704 3 -1777 1038 1517 896 3 -1736 1154 1525 1803 3 -977 1330 1045 1140 3 -1322 427 1178 1251 3 -815 1322 783 478 3 -1274 663 1217 756 3 -442 1499 1760 1612 3 -1197 62 133 296 3 -1202 1604 820 1592 3 -1330 441 1932 388 3 -491 42 802 1294 3 -469 1351 982 1030 3 -1227 1652 1906 1510 3 -1561 1424 1350 887 3 -630 1324 1112 855 3 -484 1118 474 1405 3 -1149 1084 156 606 3 -448 1661 1201 1021 3 -985 582 1720 1488 3 -1143 582 1042 1382 3 -1491 651 641 812 3 -313 1271 1328 314 3 -1058 508 707 1850 3 -1572 628 997 641 3 -1914 404 1003 1379 3 -188 25 1122 1179 3 -1348 687 1534 72 3 -1373 1615 1368 1193 3 -1114 871 733 852 3 -493 73 529 929 3 -1609 522 19 1927 3 -1050 890 854 1235 3 -1112 196 1548 1324 3 -1639 982 1810 1030 3 -1873 688 1215 34 3 -1597 1698 1174 1790 3 -896 644 365 1434 3 -633 666 963 667 3 -862 1453 41 564 3 -813 425 93 1852 3 -597 33 952 1620 3 -944 1364 588 1504 3 -1064 573 1627 1532 3 -1626 1784 923 1243 3 -1352 700 662 605 3 -1144 1827 304 873 3 -864 1105 1192 1446 3 -983 533 1900 1526 3 -1260 1770 1692 1598 3 -392 1292 1476 126 3 -125 1882 1548 1119 3 -1809 1354 1450 1034 3 -1259 181 779 164 3 -1448 1507 1672 1142 3 -631 1161 16 1308 3 -1567 1203 131 1357 3 -612 550 912 1740 3 -340 1186 369 1049 3 -365 1434 555 1104 3 -1217 1519 1486 801 3 -849 555 734 579 3 -1752 56 499 1809 3 -1774 14 886 1444 3 -1744 3 1840 1546 3 -1901 1118 1264 484 3 -1858 91 476 1621 3 -88 559 646 926 3 -1192 1270 867 1175 3 -1049 340 1344 369 3 -1170 1662 1407 1660 3 -1272 210 528 1590 3 -1876 656 788 1279 3 -635 476 690 1621 3 -225 231 1915 264 3 -154 919 595 1211 3 -1121 452 446 1782 3 -1691 1160 1005 461 3 -812 1196 1571 911 3 -432 1692 1887 1501 3 -878 1286 1411 519 3 -1551 231 1201 1806 3 -291 1219 1091 670 3 -111 50 940 958 3 -407 1312 1826 342 3 -1524 800 1582 803 3 -1014 1363 410 411 3 -1706 1030 59 1810 3 -935 701 1290 943 3 -494 1185 1522 1778 3 -1565 626 33 497 3 -937 1547 1552 714 3 -1359 1434 1365 1188 3 -883 50 958 158 3 -1433 1185 1033 1143 3 -977 1140 1410 1415 3 -1184 980 602 1801 3 -812 668 1571 1483 3 -557 1483 1654 1082 3 -1858 91 1621 148 3 -224 244 1467 310 3 -1297 1777 896 1151 3 -901 1508 1336 472 3 -1841 1596 1471 1655 3 -1722 1636 1262 1089 3 -209 796 1573 788 3 -1140 977 1410 517 3 -1929 960 187 47 3 -1183 476 1200 676 3 -702 1135 929 73 3 -1183 1015 676 78 3 -248 1015 1183 78 3 -1633 1065 1168 665 3 -22 1031 1928 1536 3 -1169 1429 300 1018 3 -1015 1183 476 248 3 -1015 676 476 1183 3 -1494 626 949 1028 3 -1780 1090 23 1786 3 -1940 435 922 216 3 -1229 839 1376 851 3 -1176 811 1662 1407 3 -1927 522 19 569 3 -153 535 1267 749 3 -324 1663 451 1872 3 -1762 1309 850 5 3 -1442 1489 1071 10 3 -1111 972 799 484 3 -211 197 1841 351 3 -489 956 772 1212 3 -902 1836 665 1328 3 -1936 760 367 808 3 -1652 1472 92 425 3 -1399 1241 1320 377 3 -1231 1535 631 1308 3 -637 1394 1225 347 3 -265 541 230 1686 3 -1256 230 1686 305 3 -1088 1803 1770 1426 3 -1095 791 53 1323 3 -653 1226 1470 1422 3 -721 726 1012 1224 3 -1173 904 1332 1824 3 -1393 1562 1445 1625 3 -490 318 1917 1863 3 -1675 1207 921 716 3 -1781 553 1050 890 3 -1387 577 1567 981 3 -1530 1089 366 1461 3 -1398 457 1057 1060 3 -1616 905 558 810 3 -1829 1207 1918 1868 3 -1097 1765 1054 1918 3 -1732 1154 1803 1088 3 -547 1443 821 1472 3 -335 1771 233 1131 3 -490 42 1190 748 3 -490 318 1098 1917 3 -1784 1785 1626 923 3 -1584 1498 928 1658 3 -752 21 1830 1755 3 -1439 1749 521 777 3 -1191 1041 572 1169 3 -1918 1207 472 1765 3 -364 397 1951 1123 3 -1481 1189 1017 625 3 -1131 1868 862 1453 3 -231 1806 1808 306 3 -292 691 62 141 3 -1530 14 1774 1109 3 -1142 1029 1010 1448 3 -1106 1105 1446 530 3 -1446 1105 943 530 3 -1286 624 1623 975 3 -1384 1338 1704 1060 3 -864 1105 1446 1106 3 -1446 599 1106 1831 3 -1301 1844 521 998 3 -1834 1338 1398 1704 3 -1708 1632 748 178 3 -437 1395 1887 459 3 -110 1219 842 1091 3 -110 1091 589 127 3 -1841 1587 1929 1471 3 -110 291 1091 127 3 -848 585 1257 1735 3 -581 1453 1131 564 3 -943 1290 1364 701 3 -1083 687 1397 729 3 -854 1366 784 1846 3 -894 755 416 1816 3 -1457 1811 1071 910 3 -553 945 1026 1637 3 -1047 1779 1823 345 3 -793 1184 1484 600 3 -649 829 542 32 3 -608 934 1337 375 3 -854 1846 784 1637 3 -600 1184 1484 618 3 -1528 1184 1484 1202 3 -600 1184 618 1421 3 -1832 1800 1148 1080 3 -1630 1199 1251 414 3 -1876 788 1392 1279 3 -1498 1584 1947 966 3 -1672 1507 683 1142 3 -1788 944 554 1737 3 -478 1367 624 752 3 -657 574 182 925 3 -1446 1052 1385 647 3 -659 852 950 534 3 -657 181 700 779 3 -1516 1382 638 950 3 -926 1092 786 413 3 -532 971 638 950 3 -533 1667 1838 677 3 -526 1850 158 1497 3 -940 1850 36 958 3 -1779 1047 1823 954 3 -848 985 1257 585 3 -393 1653 464 1878 3 -526 707 1850 1497 3 -1955 1135 606 156 3 -1181 1248 1904 1428 3 -1840 1687 1546 3 3 -732 1029 1267 535 3 -1926 1405 694 1238 3 -694 1405 987 1238 3 -1934 443 1304 1501 3 -1460 482 1003 1355 3 -982 506 1101 1639 3 -908 1752 770 695 3 -227 1633 277 665 3 -404 1111 376 799 3 -111 1219 486 940 3 -1305 375 762 480 3 -1404 1477 1159 1821 3 -1065 689 262 1168 3 -1250 83 935 1715 3 -24 808 1538 1404 3 -1633 1168 262 11 3 -1741 966 1584 777 3 -1587 1869 47 1929 3 -411 1861 410 1496 3 -119 907 481 1526 3 -860 244 274 205 3 -1677 844 1612 447 3 -761 766 1675 485 3 -1136 915 1126 1279 3 -1227 734 965 1776 3 -1059 494 1185 1143 3 -1379 404 799 405 3 -965 867 1227 1776 3 -1172 1174 1597 1662 3 -1138 572 721 1935 3 -1028 626 949 540 3 -102 498 482 1292 3 -1013 1104 1359 316 3 -568 440 1288 1037 3 -1325 723 969 909 3 -657 574 925 537 3 -1887 1736 1711 1501 3 -1513 1170 1787 1883 3 -1613 1857 805 1306 3 -1929 1587 1869 1471 3 -1203 981 1567 294 3 -488 757 1387 789 3 -491 1741 966 1584 3 -49 1754 1816 1685 3 -1703 696 965 1906 3 -666 760 1936 1404 3 -1665 1202 1921 881 3 -912 974 353 165 3 -1559 1660 1233 1522 3 -1047 1576 345 1721 3 -1755 21 307 752 3 -1524 803 1582 1368 3 -56 908 1081 1354 3 -1290 1128 357 412 3 -1560 1885 724 1881 3 -89 1950 222 559 3 -957 841 488 920 3 -1639 1559 1126 1399 3 -764 1213 1795 1710 3 -365 644 1776 1434 3 -1294 1741 1656 1838 3 -1386 68 1258 991 3 -771 485 596 109 3 -1227 93 157 813 3 -1386 68 991 1949 3 -882 1530 1490 14 3 -1609 261 245 28 3 -1075 203 257 1340 3 -1682 755 1398 1816 3 -1075 257 990 1340 3 -49 375 1685 1400 3 -1441 647 1578 1265 3 -1156 79 1389 1250 3 -1020 569 1643 769 3 -1080 1832 1691 1148 3 -1760 357 1364 356 3 -910 1797 303 1571 3 -569 1243 1643 769 3 -1029 184 674 749 3 -1643 1243 1117 769 3 -394 393 1011 1878 3 -1729 1699 438 703 3 -1384 1536 1804 1210 3 -453 462 423 1539 3 -757 488 1514 789 3 -690 1951 746 745 3 -1217 18 1486 1519 3 -1360 304 222 1144 3 -1350 1606 1492 986 3 -28 245 1609 278 3 -1625 1834 1314 18 3 -1212 969 1855 1946 3 -1648 659 552 1142 3 -815 1411 478 717 3 -1282 14 964 818 3 -1032 988 754 1263 3 -1670 621 569 19 3 -486 940 36 958 3 -145 1139 177 1341 3 -1341 974 1139 177 3 -879 1600 1426 1193 3 -1844 171 1428 1904 3 -1127 1573 796 518 3 -538 793 1664 1546 3 -988 317 1263 319 3 -163 702 529 1518 3 -532 1877 659 1093 3 -1452 610 1515 1547 3 -79 1389 645 1156 3 -630 1086 1324 855 3 -232 233 1374 282 3 -1495 373 668 812 3 -285 1293 1165 1555 3 -1375 629 738 893 3 -1248 702 383 529 3 -1529 247 95 1679 3 -1915 1201 625 1551 3 -1551 625 1015 676 3 -467 399 1425 398 3 -1374 267 774 1131 3 -22 1375 738 893 3 -1380 1521 1025 701 3 -1310 734 223 579 3 -911 812 641 1220 3 -985 1720 904 1824 3 -89 1149 1955 559 3 -1555 1293 1165 198 3 -1716 1041 1191 1169 3 -652 1107 1490 1164 3 -351 197 1596 1221 3 -337 973 1406 1001 3 -1017 1135 1950 304 3 -1444 1721 1234 1576 3 -1878 394 414 1011 3 -1293 1164 1158 598 3 -47 1841 1929 211 3 -1600 1193 1368 1426 3 -892 364 690 1951 3 -759 735 1095 148 3 -207 1296 454 310 3 -1201 231 713 1806 3 -660 663 1217 1274 3 -1513 1883 1614 1170 3 -1024 1107 1695 1261 3 -337 973 121 1406 3 -1267 1142 552 539 3 -226 1012 822 1224 3 -271 1590 1303 663 3 -835 683 1093 16 3 -1341 437 1887 1420 3 -1316 352 1905 1138 3 -1507 422 1130 1430 3 -1616 1141 104 1948 3 -428 879 1600 1088 3 -1278 650 788 806 3 -1621 91 616 148 3 -765 1721 1444 1576 3 -1930 477 1766 448 3 -285 1293 1158 138 3 -581 564 1131 541 3 -1034 1888 1925 458 3 -1955 1753 678 1149 3 -1476 1158 1246 285 3 -1201 448 1021 854 3 -644 1423 1376 1327 3 -490 1098 1249 748 3 -847 598 509 617 3 -847 96 598 617 3 -727 1272 889 334 3 -371 598 847 96 3 -495 1223 568 1276 3 -1616 1141 1948 558 3 -1692 899 1887 1501 3 -1451 1116 243 363 3 -348 620 615 999 3 -1867 534 1097 950 3 -511 1281 941 648 3 -1232 596 218 1429 3 -1337 753 1327 607 3 -1295 613 1287 1617 3 -1455 1452 1552 872 3 -378 904 1550 1173 3 -260 1411 717 775 3 -540 543 949 1028 3 -1886 837 1175 1511 3 -47 197 1587 1841 3 -1954 959 496 745 3 -1716 1429 596 1232 3 -1231 124 1812 971 3 -1266 650 597 976 3 -1284 933 763 203 3 -532 971 1231 546 3 -1469 800 39 946 3 -1261 1283 350 1860 3 -337 1304 1300 1001 3 -899 1501 1770 1736 3 -1232 1429 300 1169 3 -1520 596 218 1232 3 -494 1143 1059 452 3 -693 1589 1004 848 3 -1802 576 1462 1622 3 -896 644 1038 365 3 -1601 184 749 674 3 -445 1156 645 1416 3 -1484 1528 525 618 3 -1226 1431 989 1930 3 -776 1282 1556 1024 3 -140 88 646 926 3 -1852 1105 813 425 3 -1950 1017 304 1827 3 -1746 714 937 1552 3 -1319 219 279 263 3 -1211 1141 558 1948 3 -1950 1017 1827 916 3 -24 1404 1538 1159 3 -467 398 1425 1441 3 -1494 1028 949 787 3 -1531 1490 818 652 3 -238 270 1572 975 3 -308 238 1572 1274 3 -304 1827 929 873 3 -1408 237 280 961 3 -1029 536 1418 1010 3 -536 1138 1230 1191 3 -1599 534 1508 1648 3 -981 1607 789 510 3 -916 1132 1481 1412 3 -1226 1431 1930 1843 3 -738 1384 1060 36 3 -1536 1377 1804 1210 3 -1807 562 1171 144 3 -1408 1489 1623 280 3 -9 665 1436 874 3 -1247 1718 36 514 3 -1569 1363 462 1014 3 -1359 1434 555 1365 3 -363 309 1163 67 3 -936 1319 572 1169 3 -612 1352 662 605 3 -1699 1729 1283 703 3 -1015 476 635 248 3 -1117 300 228 219 3 -804 1718 1247 514 3 -90 1200 476 746 3 -1885 781 1416 724 3 -1622 1210 1031 1536 3 -958 1247 514 143 3 -143 50 958 883 3 -1247 514 36 958 3 -1717 1441 1265 82 3 -1752 1602 1362 365 3 -278 28 520 1609 3 -1873 1383 1215 998 3 -1016 1118 1575 474 3 -115 1048 841 147 3 -1469 800 946 1582 3 -443 924 1426 1582 3 -1711 1736 1525 443 3 -987 1896 694 423 3 -807 694 1764 423 3 -1278 1152 1509 61 3 -1516 733 1587 1869 3 -586 1631 1334 903 3 -1923 1521 1380 701 3 -484 712 792 799 3 -1065 604 1784 1785 3 -805 1926 1335 1872 3 -498 482 1292 611 3 -1852 1128 1731 813 3 -1323 635 1865 1422 3 -1677 470 387 1820 3 -249 1305 762 480 3 -1011 636 473 1046 3 -1919 92 1510 1906 3 -501 427 1678 556 3 -481 343 735 724 3 -1065 1785 1784 665 3 -1367 1748 1897 1500 3 -866 712 474 3 3 -438 817 598 426 3 -1083 1397 135 729 3 -1051 1479 976 431 3 -1176 1512 1407 915 3 -1154 1178 1245 556 3 -1154 1178 671 1245 3 -697 29 766 106 3 -542 741 1125 1281 3 -1692 459 456 432 3 -335 1235 1503 1745 3 -513 1905 352 536 3 -605 868 889 727 3 -1705 207 1188 454 3 -1448 1799 674 751 3 -1323 1470 53 1422 3 -1884 19 1707 1670 3 -1718 1536 22 738 3 -1384 738 1718 36 3 -1586 794 1506 1227 3 -1573 656 1876 1791 3 -887 1611 1424 1656 3 -1421 987 1896 694 3 -14 824 964 818 3 -1931 1141 104 1616 3 -1264 1358 1895 1269 3 -513 1905 536 1252 3 -751 513 536 1252 3 -765 998 1047 1749 3 -1530 14 1109 776 3 -1209 1260 1603 395 3 -497 1714 855 1894 3 -368 394 1529 414 3 -454 375 607 762 3 -985 904 1619 1671 3 -1356 396 1954 328 3 -430 838 493 206 3 -493 1189 1865 1129 3 -437 1887 828 1341 3 -1683 898 982 952 3 -1496 1087 1641 709 3 -374 1264 465 1269 3 -449 1156 445 1416 3 -1145 1554 1443 577 3 -117 116 489 823 3 -705 1344 1657 1782 3 -248 91 476 1858 3 -408 1333 690 1621 3 -600 979 799 1605 3 -627 1317 562 1149 3 -1244 714 1746 1552 3 -638 733 971 1899 3 -473 1931 1402 1616 3 -1868 862 1765 382 3 -1612 1499 588 1820 3 -1049 715 1767 1782 3 -1040 378 1208 1173 3 -1794 1921 1445 1068 3 -413 520 1092 786 3 -548 1260 858 1209 3 -301 1065 227 1785 3 -1273 48 1454 1842 3 -1260 1024 672 666 3 -1177 1711 1934 1949 3 -858 1024 1260 666 3 -1209 1260 858 1024 3 -1209 776 1260 1024 3 -1949 353 68 1259 3 -612 1711 1949 912 3 -1556 776 1649 1282 3 -982 819 1030 1639 3 -1603 1628 1594 1461 3 -1577 731 492 1692 3 -78 1200 503 289 3 -78 676 1200 289 3 -1826 1333 408 1621 3 -1934 1711 353 1949 3 -489 1892 1855 693 3 -472 1194 901 1122 3 -261 1807 560 1043 3 -1282 1531 1039 1072 3 -1249 490 1193 1055 3 -1688 1031 668 1495 3 -1187 932 1690 1096 3 -1476 1158 1953 817 3 -270 1408 961 237 3 -9 874 886 1552 3 -1949 1711 353 912 3 -714 1547 1552 1455 3 -55 1256 1360 266 3 -1536 1210 1378 1377 3 -1065 1784 689 1168 3 -60 1904 521 677 3 -1775 1216 1262 1599 3 -1187 179 1361 767 3 -266 1360 222 1144 3 -1282 1649 964 14 3 -479 780 1723 897 3 -1280 1939 752 307 3 -390 1535 323 631 3 -666 1477 672 760 3 -12 570 1695 1821 3 -659 532 1093 1943 3 -631 730 16 1161 3 -1952 76 845 1265 3 -751 513 352 536 3 -1722 1089 1461 1744 3 -1452 888 872 1449 3 -779 912 1259 164 3 -504 1593 49 480 3 -1358 712 1264 474 3 -402 438 1909 1699 3 -1306 1629 16 1474 3 -110 940 589 842 3 -970 1645 1750 930 3 -795 415 605 608 3 -820 942 1604 949 3 -1602 948 1362 1517 3 -539 659 552 1146 3 -789 728 1514 1126 3 -252 1348 996 72 3 -1650 1600 879 42 3 -1268 1078 1790 1813 3 -1296 1365 1359 579 3 -1193 1615 754 1373 3 -1070 764 1795 1710 3 -942 626 1604 949 3 -1604 626 505 540 3 -111 50 958 143 3 -654 129 878 1371 3 -1677 1440 1612 844 3 -1715 1062 1668 412 3 -1325 1391 1433 1810 3 -535 184 1029 749 3 -579 1296 1365 302 3 -344 1683 1101 1574 3 -857 1848 1081 1167 3 -1692 1501 1577 731 3 -1692 1770 731 1598 3 -1593 1642 49 375 3 -33 626 942 1494 3 -1495 812 1491 373 3 -1276 195 1030 827 3 -374 1460 1269 392 3 -163 702 1518 73 3 -1202 820 1604 1794 3 -627 38 86 413 3 -1209 858 427 1199 3 -1846 585 1735 1257 3 -467 1466 723 1425 3 -605 1740 868 727 3 -1703 1175 1362 471 3 -879 42 1600 1193 3 -105 104 1948 595 3 -195 1044 45 1276 3 -706 1655 623 1819 3 -522 621 19 569 3 -793 1575 1184 1421 3 -1778 969 1728 1855 3 -768 1524 1469 1582 3 -1222 1340 990 1447 3 -312 1278 209 1127 3 -312 814 1278 1127 3 -1916 1678 1813 1463 3 -1588 1149 736 790 3 -245 1328 522 1063 3 -1502 1602 811 1512 3 -524 964 360 1693 3 -17 1675 1207 921 3 -1027 51 1738 178 3 -1463 1628 1790 1268 3 -559 678 475 926 3 -1535 730 323 631 3 -1361 688 1940 1215 3 -664 1361 897 1940 3 -409 27 1311 1624 3 -1697 859 323 730 3 -1725 682 1541 150 3 -1834 1816 1398 1338 3 -1452 986 888 1449 3 -1682 1685 1816 406 3 -1628 1463 1790 1921 3 -350 1860 866 1546 3 -1149 1317 562 678 3 -1407 1512 1427 915 3 -921 581 648 1281 3 -581 856 1281 716 3 -581 741 1281 856 3 -581 741 648 1281 3 -1426 1419 731 1193 3 -453 698 1238 462 3 -668 1644 373 1495 3 -1546 866 3 1687 3 -1659 798 970 930 3 -1048 380 115 1390 3 -1625 1491 18 1314 3 -705 827 583 1417 3 -1274 752 624 1280 3 -1748 1500 1910 1409 3 -1666 1478 1054 382 3 -803 1134 924 1368 3 -1283 1860 703 1505 3 -616 364 91 408 3 -1627 1035 842 1338 3 -1170 1795 566 948 3 -1119 1902 1882 1548 3 -1090 618 1722 1484 3 -28 87 86 1807 3 -546 638 1899 1475 3 -1028 1882 1714 540 3 -917 725 1800 544 3 -752 246 1480 21 3 -129 1480 878 519 3 -985 582 1488 585 3 -789 1387 1357 981 3 -1341 974 828 1139 3 -1843 565 1431 1570 3 -814 1081 656 1791 3 -79 1295 561 645 3 -1805 1435 1234 1707 3 -1208 1793 1336 487 3 -632 1617 645 1312 3 -752 1939 1079 307 3 -1212 1694 1946 1730 3 -1274 975 624 752 3 -394 1371 1011 393 3 -1663 1335 1872 805 3 -1497 1375 1800 629 3 -553 1026 523 1050 3 -1428 1870 1248 1904 3 -727 1273 1553 415 3 -500 1842 1743 48 3 -1289 785 861 1240 3 -531 1289 861 1240 3 -1278 1148 806 1818 3 -597 1403 728 1155 3 -1945 1799 1448 1379 3 -1497 1375 629 36 3 -1185 969 1212 1325 3 -730 1306 16 1023 3 -997 573 1532 756 3 -1105 1062 1290 530 3 -490 1193 1373 42 3 -1669 533 1837 1248 3 -1790 1921 1172 881 3 -533 1560 907 832 3 -1697 30 1640 1099 3 -1399 1559 1241 377 3 -1399 1559 1126 1241 3 -982 506 1351 469 3 -1325 58 1559 969 3 -1325 1559 1185 969 3 -665 277 902 1436 3 -1784 604 874 610 3 -1891 322 387 470 3 -1134 588 1009 1504 3 -582 1143 1042 951 3 -386 966 1917 619 3 -1070 1710 1170 1662 3 -383 1248 1635 1773 3 -1549 902 1328 522 3 -1568 396 1954 1702 3 -1800 1152 1148 1080 3 -1530 1774 1350 1109 3 -1453 862 1765 1868 3 -304 929 1195 873 3 -137 57 112 508 3 -1014 1211 1016 1363 3 -1234 1805 1707 1721 3 -1559 58 1126 692 3 -193 1152 725 1080 3 -1884 1742 1110 786 3 -993 1482 611 604 3 -850 1796 5 1763 3 -1061 363 258 1116 3 -363 243 67 258 3 -1668 935 1389 1290 3 -1184 1896 1307 1421 3 -512 1754 1593 516 3 -602 1068 1644 1495 3 -1831 1674 955 1954 3 -1109 1439 1650 1658 3 -924 1134 1419 1368 3 -1134 1419 973 924 3 -1596 1221 715 159 3 -759 407 1826 342 3 -939 508 1761 1058 3 -1282 1490 14 818 3 -782 1603 1461 1628 3 -482 1003 1438 979 3 -915 789 692 1126 3 -1187 179 1096 1938 3 -547 1472 1703 1886 3 -1945 1799 421 674 3 -593 861 531 1299 3 -979 799 3 600 3 -1003 799 3 979 3 -1174 1078 1813 1790 3 -1407 1427 1559 915 3 -60 983 1904 677 3 -482 993 992 816 3 -1258 1733 991 349 3 -1258 584 1733 349 3 -886 1444 14 479 3 -523 1893 1568 1702 3 -1472 1652 1906 965 3 -855 125 1894 1882 3 -455 1044 469 898 3 -1704 1398 1057 1060 3 -408 1204 364 892 3 -461 433 1902 1160 3 -1126 915 1241 1559 3 -713 541 1686 825 3 -1159 12 1821 570 3 -1126 1176 1241 915 3 -101 516 54 100 3 -278 1000 1772 1927 3 -1745 1254 1004 1478 3 -1220 628 641 911 3 -1272 868 889 210 3 -1275 742 1288 440 3 -1745 335 1374 1131 3 -1305 98 75 418 3 -1683 580 891 1324 3 -879 1556 1598 1260 3 -1950 1827 304 1360 3 -835 730 1306 16 3 -1898 1208 1599 1449 3 -845 1730 327 328 3 -1332 1720 1090 1780 3 -768 1426 1368 1582 3 -1377 1704 1834 1579 3 -1525 443 1803 1582 3 -747 185 807 698 3 -196 461 597 1266 3 -1513 1070 1170 1614 3 -296 939 1761 1197 3 -765 767 1749 1187 3 -1311 188 1581 152 3 -1197 1761 894 939 3 -348 615 123 517 3 -591 904 1671 436 3 -837 692 58 1427 3 -1157 1179 1537 1716 3 -827 1957 1433 1417 3 -1840 1860 1687 1953 3 -894 1321 707 1058 3 -1020 766 485 1675 3 -617 1723 262 1293 3 -1551 676 1015 78 3 -586 1586 1788 644 3 -1660 1883 1847 1170 3 -850 1941 420 558 3 -1541 359 932 682 3 -1766 648 1110 1370 3 -394 1653 393 1878 3 -927 1847 65 1595 3 -1148 1313 806 1818 3 -846 532 1943 1712 3 -1163 508 707 1321 3 -1401 1382 1684 638 3 -1146 852 971 659 3 -1561 639 1635 1226 3 -1684 1113 638 1382 3 -1783 931 201 256 3 -865 201 931 256 3 -1744 1636 1840 3 3 -1843 477 669 1766 3 -1877 722 1146 743 3 -1359 1296 1756 224 3 -663 308 997 756 3 -1312 632 65 645 3 -226 1785 259 1224 3 -462 423 410 1363 3 -587 1881 53 1069 3 -1172 1202 820 881 3 -1294 1881 53 587 3 -1623 1408 717 1286 3 -1424 710 1373 1912 3 -872 1898 714 1455 3 -377 1320 1474 881 3 -666 963 667 1936 3 -929 1827 625 873 3 -782 1628 1461 1744 3 -1744 1840 782 1546 3 -1424 1600 428 1650 3 -1057 1579 1432 1176 3 -1715 412 1668 357 3 -1418 1029 1010 1142 3 -1391 956 1059 1121 3 -1262 1599 1449 1455 3 -600 1636 1744 3 3 -878 1367 478 752 3 -1744 1628 1461 655 3 -1722 1636 1089 1744 3 -654 1011 1630 414 3 -1300 121 1334 584 3 -879 428 1556 1260 3 -211 351 1655 996 3 -1755 752 307 1280 3 -99 69 762 149 3 -1217 573 18 756 3 -1450 894 1034 549 3 -756 573 18 651 3 -1838 1667 1611 1294 3 -117 706 823 252 3 -1883 1757 1614 23 3 -930 1261 1024 1695 3 -478 752 624 1286 3 -1393 1664 782 538 3 -368 1936 667 367 3 -1020 1000 569 1772 3 -383 1017 1481 1189 3 -916 1412 1481 625 3 -1447 696 555 770 3 -1660 1847 585 1728 3 -119 1900 1560 907 3 -1671 1589 1382 985 3 -1660 1883 585 1847 3 -906 1694 956 489 3 -1279 656 788 806 3 -654 1371 878 1011 3 -539 1942 1093 1877 3 -1631 176 1334 831 3 -1713 876 592 639 3 -976 788 209 1278 3 -686 1758 493 430 3 -1033 1565 819 1223 3 -148 1758 686 1858 3 -1414 1926 1413 1076 3 -1717 1441 723 1956 3 -1363 980 423 1861 3 -690 892 1951 745 3 -1954 745 466 955 3 -1623 1408 280 717 3 -861 1688 1031 668 3 -1487 105 1211 411 3 -1041 714 937 1746 3 -1099 30 1640 45 3 -760 750 1395 450 3 -1421 1076 618 1413 3 -690 364 746 1951 3 -1135 702 929 383 3 -896 1151 1337 1400 3 -1462 1205 804 190 3 -667 367 680 368 3 -1870 172 1135 702 3 -1059 1212 956 1325 3 -903 1506 944 586 3 -1400 896 1104 1434 3 -986 1350 1435 1431 3 -163 1870 1248 702 3 -628 1082 641 911 3 -762 1642 934 640 3 -1142 1507 1943 539 3 -151 1301 1844 1198 3 -1283 1107 1695 703 3 -1842 48 297 1353 3 -894 1034 549 1321 3 -896 1423 644 1434 3 -969 1728 1855 1946 3 -53 1667 1560 1294 3 -1130 451 468 1926 3 -710 1583 1218 1912 3 -664 824 479 897 3 -1853 750 563 37 3 -163 1904 1248 1870 3 -1434 1188 1327 1365 3 -588 1760 903 1499 3 -1148 893 787 629 3 -313 6 227 1271 3 -423 987 1896 980 3 -1759 1505 1763 1309 3 -1414 1076 1413 1605 3 -1328 217 1836 313 3 -902 217 1836 1328 3 -1328 1271 923 314 3 -313 6 1271 314 3 -665 1271 923 1328 3 -1169 1319 572 1935 3 -475 1256 511 1412 3 -1610 1039 463 1072 3 -672 1598 1027 1610 3 -1477 1282 1610 1072 3 -1512 1517 948 1602 3 -613 84 1204 632 3 -1069 1025 953 587 3 -1231 390 631 1535 3 -1226 1470 1635 653 3 -453 807 1932 423 3 -408 364 690 892 3 -980 1363 987 1575 3 -614 841 920 1051 3 -1563 1551 1021 1007 3 -1297 1777 1517 896 3 -1033 1023 1565 1223 3 -1231 346 1942 631 3 -686 1242 635 493 3 -1950 1827 1360 916 3 -875 1011 429 473 3 -477 653 1481 1661 3 -390 323 346 631 3 -1383 170 1588 736 3 -1589 582 1382 985 3 -1189 1661 1129 625 3 -1754 1553 516 704 3 -982 506 1639 1810 3 -98 480 504 295 3 -683 1605 1076 1507 3 -501 1445 1393 1562 3 -1913 1738 1053 456 3 -1529 654 94 1792 3 -454 316 1359 1188 3 -1201 1412 448 44 3 -1026 945 1751 1637 3 -1954 496 959 1568 3 -292 1545 141 254 3 -1507 1605 1076 1130 3 -53 953 592 639 3 -1569 1405 987 1118 3 -712 1003 3 1355 3 -643 1745 774 1254 3 -669 565 1843 1570 3 -1816 1754 1255 406 3 -1446 647 571 566 3 -663 997 1532 756 3 -1226 1635 1843 477 3 -1348 1655 706 252 3 -1307 1764 1801 1564 3 -740 816 1191 572 3 -1252 751 1379 1448 3 -166 190 1066 1205 3 -703 1107 652 1164 3 -1262 1636 1515 1089 3 -1800 1152 1818 1148 3 -1430 1942 1093 539 3 -504 679 691 1197 3 -1883 354 1847 1787 3 -1883 1787 1847 1170 3 -728 1403 1514 1155 3 -1502 1136 1512 811 3 -1815 1610 1853 1027 3 -9 874 1552 1784 3 -1073 543 35 1094 3 -762 1642 1593 375 3 -1886 1192 837 647 3 -1846 1002 585 1257 3 -865 256 931 890 3 -495 440 568 1037 3 -1252 1448 979 1672 3 -1413 484 600 793 3 -1853 1610 672 1027 3 -1885 781 724 1881 3 -1896 1801 1184 1307 3 -1178 1845 633 1346 3 -489 384 116 117 3 -385 384 489 117 3 -1355 482 1438 1476 3 -69 101 66 334 3 -495 1618 440 977 3 -1662 1070 1174 1698 3 -566 647 1192 1446 3 -1849 392 102 1460 3 -1035 1219 842 1654 3 -1439 1109 1576 1649 3 -1626 1041 936 572 3 -1192 566 1270 1175 3 -1338 842 1654 1035 3 -1129 653 1661 1189 3 -467 399 1466 1425 3 -916 1412 625 825 3 -1626 1041 1746 936 3 -397 396 745 466 3 -1476 1158 391 1246 3 -681 1081 1354 1137 3 -120 1386 1300 1934 3 -622 1501 1934 1304 3 -452 1957 71 1875 3 -1610 1072 1853 1477 3 -1897 624 783 478 3 -889 700 1352 605 3 -1202 1564 1604 1937 3 -1717 1441 1956 1265 3 -1747 1332 1090 23 3 -631 730 1161 1535 3 -707 1354 549 1313 3 -707 681 1354 1313 3 -681 1137 1313 806 3 -1584 928 1190 42 3 -1563 1007 890 865 3 -580 1683 1574 1324 3 -1867 1194 472 1122 3 -1754 1553 660 833 3 -1321 1354 549 707 3 -1321 681 1354 707 3 -1590 704 660 663 3 -840 1245 415 833 3 -1771 251 233 382 3 -964 1693 160 1690 3 -45 827 1640 1147 3 -1640 827 583 1147 3 -1373 754 802 545 3 -55 1360 222 266 3 -1520 769 1117 1874 3 -1178 1732 633 1251 3 -619 491 966 1917 3 -705 583 1308 1298 3 -964 1282 1854 1649 3 -1610 1854 1556 928 3 -1587 1471 1401 1516 3 -1526 907 481 162 3 -1330 388 1932 1140 3 -1643 1520 1115 769 3 -1643 485 1115 1520 3 -1643 1232 1520 936 3 -310 1296 1359 224 3 -1055 1493 754 1615 3 -545 754 802 1009 3 -1615 1493 754 1440 3 -955 745 466 1123 3 -1268 1828 1078 1916 3 -1482 1476 1438 993 3 -171 1870 1428 1904 3 -1847 959 1855 1728 3 -485 1232 1520 1643 3 -1102 1118 1901 1405 3 -1134 1615 1009 1677 3 -196 433 1548 461 3 -1839 913 471 1607 3 -1361 179 688 1215 3 -768 1524 1368 1218 3 -61 1673 209 1691 3 -1528 1474 525 1629 3 -1049 1475 1684 1782 3 -1361 1903 435 1940 3 -1691 650 1278 1148 3 -632 745 1954 955 3 -1710 1213 1795 948 3 -1223 568 1640 1023 3 -1361 435 897 1940 3 -1809 1354 457 1450 3 -1474 1712 951 1544 3 -780 617 479 1723 3 -1223 1640 583 1023 3 -462 1363 410 1014 3 -466 396 1954 1356 3 -1887 432 1420 437 3 -868 1272 889 727 3 -1230 1169 1138 1253 3 -1342 277 922 11 3 -64 754 1032 988 3 -1119 35 1073 744 3 -780 617 1723 11 3 -628 1220 641 1572 3 -529 702 929 73 3 -474 1211 1575 1016 3 -1709 840 1685 1682 3 -1400 608 1337 375 3 -840 1381 1709 415 3 -615 1087 1932 1801 3 -1423 1777 896 644 3 -1572 31 269 270 3 -1815 1708 748 178 3 -1431 1350 1435 565 3 -579 1365 851 1229 3 -391 817 426 1158 3 -1777 1038 896 644 3 -1162 1569 594 1014 3 -1134 588 1677 1009 3 -80 1188 302 1229 3 -1553 1273 1590 660 3 -1202 1592 820 881 3 -568 1223 1640 45 3 -667 680 1139 684 3 -938 1377 820 1057 3 -1208 1291 1898 1793 3 -1000 19 786 569 3 -580 1324 1574 1403 3 -1182 1717 467 723 3 -1451 363 857 458 3 -905 850 474 866 3 -474 905 866 538 3 -1040 904 378 1173 3 -878 752 478 1286 3 -1633 1342 277 665 3 -1109 1439 1658 1649 3 -876 1561 1713 338 3 -1278 1573 209 1127 3 -996 211 1864 1655 3 -650 1494 1028 461 3 -227 1343 1633 1065 3 -474 538 793 1768 3 -849 696 555 1447 3 -1589 1855 848 693 3 -849 1447 555 275 3 -1542 1442 1623 812 3 -787 1136 1057 1432 3 -722 124 122 1877 3 -27 852 1114 722 3 -275 990 849 1447 3 -770 1752 696 555 3 -1148 1279 806 1313 3 -1408 775 1286 204 3 -1584 1498 777 966 3 -342 1826 645 1312 3 -1193 1055 1913 1249 3 -748 51 1913 1027 3 -1553 1272 1590 1273 3 -1766 1843 1930 1370 3 -79 1156 445 1056 3 -306 267 1374 232 3 -306 267 774 1374 3 -1374 267 1131 233 3 -232 267 1374 233 3 -1524 1218 1583 1504 3 -1595 1954 927 1825 3 -1725 1498 355 777 3 -428 1424 1650 1109 3 -848 582 985 585 3 -1365 644 851 1376 3 -1671 1727 1382 950 3 -1167 1163 681 857 3 -1112 125 1548 1369 3 -1376 851 1365 1229 3 -667 1133 1139 680 3 -1763 1860 1505 1759 3 -249 762 454 149 3 -1777 863 1213 1038 3 -1560 724 791 53 3 -763 981 471 933 3 -945 1847 65 927 3 -1135 1237 1950 304 3 -1747 1550 1701 1332 3 -1572 270 1220 975 3 -1441 637 1394 1052 3 -1226 1635 477 653 3 -1954 745 927 959 3 -1722 1701 1775 1672 3 -1382 1516 1401 1789 3 -998 150 767 1873 3 -560 261 1609 28 3 -911 1489 812 1220 3 -1458 1164 1523 1293 3 -1350 1424 1492 428 3 -1942 631 324 1430 3 -847 617 479 527 3 -1208 1291 487 1040 3 -1350 1109 428 1606 3 -1003 404 799 1379 3 -1914 404 1379 142 3 -996 211 282 1864 3 -532 1093 16 1308 3 -103 404 1003 1914 3 -28 86 520 1807 3 -1915 231 1551 264 3 -789 757 1387 692 3 -1103 550 612 1740 3 -129 878 1371 1856 3 -113 526 158 221 3 -146 1689 25 1120 3 -64 590 1891 1493 3 -1807 87 86 562 3 -1864 1655 335 1348 3 -1610 1072 463 1853 3 -340 444 1344 369 3 -278 200 1609 1927 3 -1436 277 1459 922 3 -553 1563 890 865 3 -53 953 639 1611 3 -1182 467 1466 723 3 -1203 933 1284 203 3 -1465 41 1453 581 3 -41 107 1465 1453 3 -107 106 41 1465 3 -456 1913 492 1053 3 -1864 1771 282 335 3 -1453 1862 1194 809 3 -1197 1888 416 894 3 -1733 863 853 586 3 -527 617 780 11 3 -456 1053 492 321 3 -1184 1068 1484 1202 3 -1758 838 1242 493 3 -1393 1463 427 782 3 -818 1531 1282 1490 3 -249 99 762 149 3 -1463 1209 427 782 3 -751 536 1010 1252 3 -1322 1178 556 1748 3 -996 351 1655 252 3 -562 46 1149 1588 3 -1935 1319 279 263 3 -809 960 187 1929 3 -1070 1218 1524 1734 3 -1526 907 162 1527 3 -1029 751 1010 1448 3 -1063 1328 621 923 3 -1698 1070 1078 1757 3 -1274 1519 801 1500 3 -1734 1218 1524 768 3 -1520 13 1874 300 3 -1668 1290 357 412 3 -882 14 1774 1530 3 -344 506 1101 982 3 -1727 1550 1216 534 3 -792 1003 712 1460 3 -835 730 1613 1306 3 -1927 200 1609 1063 3 -1200 1702 661 553 3 -1031 1644 1378 1210 3 -1745 1131 1374 774 3 -1697 1640 1535 1099 3 -1601 1318 674 421 3 -1907 1734 1524 768 3 -995 606 1753 1955 3 -1434 644 1365 1327 3 -1702 745 1954 496 3 -1441 1052 1394 647 3 -505 517 540 1714 3 -747 441 1330 388 3 -1002 591 1366 989 3 -1179 25 1120 189 3 -804 1462 1718 1802 3 -1275 1618 440 568 3 -1392 1051 728 976 3 -805 694 1076 1629 3 -151 52 1198 171 3 -1654 486 36 514 3 -1092 1884 669 1110 3 -1143 1033 1298 951 3 -1853 1072 463 836 3 -1392 1051 976 431 3 -1605 1130 1414 1076 3 -587 1009 802 781 3 -1143 951 1298 1042 3 -1782 1347 715 1767 3 -715 1221 1186 1767 3 -1839 1752 696 770 3 -1273 1842 1303 801 3 -773 439 1874 228 3 -1814 1233 881 1597 3 -54 1473 704 271 3 -1626 1746 1243 936 3 -483 1734 1524 1907 3 -1781 737 1397 687 3 -631 1093 835 1430 3 -1785 1117 923 259 3 -1186 715 1767 1049 3 -1190 386 1632 1947 3 -1432 1494 787 1620 3 -1358 1895 1269 1309 3 -32 829 542 1326 3 -1035 1314 573 1082 3 -1119 1073 1882 1902 3 -1906 1340 696 849 3 -489 384 1730 1892 3 -855 1894 630 497 3 -1719 119 491 319 3 -458 1451 1848 857 3 -1736 1525 443 1803 3 -1721 1549 1805 19 3 -1389 1715 1668 1760 3 -149 207 1705 454 3 -739 180 753 1705 3 -739 1705 753 607 3 -149 207 180 1705 3 -1786 1757 1078 1268 3 -33 1620 942 1126 3 -905 473 1046 1817 3 -1503 1004 1235 706 3 -259 1785 6 923 3 -1387 757 900 692 3 -383 995 1132 1135 3 -1757 1828 710 1070 3 -623 693 1004 706 3 -727 1642 1553 516 3 -1769 318 1098 490 3 -650 597 728 1620 3 -623 1004 1503 706 3 -281 1571 303 236 3 -163 171 1870 172 3 -1239 896 1104 1400 3 -463 1632 1708 178 3 -898 819 982 952 3 -591 985 1004 1671 3 -1933 1921 1790 881 3 -1033 1399 1320 377 3 -1020 1742 1675 485 3 -1179 189 218 1429 3 -532 971 950 659 3 -328 1920 135 1568 3 -630 1894 1618 497 3 -328 396 1954 1568 3 -1797 1483 1802 557 3 -1537 1122 596 1179 3 -523 1568 1855 1026 3 -516 54 704 1590 3 -1033 1399 1565 1320 3 -647 1052 1385 1265 3 -105 1948 1211 595 3 -1606 776 1109 1556 3 -1169 219 263 1018 3 -764 554 1213 800 3 -1067 761 1689 1122 3 -1297 1517 499 896 3 -1945 674 421 1507 3 -775 519 1286 204 3 -1569 1118 987 1016 3 -1940 1903 216 688 3 -666 1260 963 672 3 -1019 538 782 350 3 -1113 532 1298 1308 3 -992 611 482 726 3 -1134 1677 588 470 3 -1537 1867 472 1122 3 -1265 647 1578 1946 3 -1746 1626 1243 1552 3 -667 368 680 684 3 -1187 777 1749 1439 3 -1393 1628 782 1664 3 -671 1346 947 1409 3 -1004 591 1254 1257 3 -1929 1841 382 211 3 -1818 192 221 1509 3 -1497 192 221 1818 3 -1476 482 1438 993 3 -1208 1040 487 378 3 -1146 27 852 1311 3 -1274 1303 660 663 3 -1245 801 500 1273 3 -845 1730 575 1265 3 -333 449 343 1885 3 -1943 1712 1093 683 3 -765 1749 1439 1187 3 -722 27 852 1146 3 -1776 965 365 555 3 -1623 624 783 1519 3 -1057 1377 820 1579 3 -1192 837 566 1175 3 -1382 1684 914 1789 3 -1340 913 471 770 3 -506 1696 1810 1706 3 -1550 534 378 1208 3 -1155 728 1620 1126 3 -1730 1946 575 1265 3 -240 276 1791 877 3 -1946 959 571 1728 3 -1446 571 1595 566 3 -667 828 1139 1133 3 -1194 1862 146 1558 3 -1269 1759 1763 1309 3 -1198 736 1301 1428 3 -26 771 1689 1120 3 -1260 1088 1770 879 3 -928 1854 1039 1610 3 -1678 1445 501 1562 3 -959 1568 1855 1946 3 -991 657 537 662 3 -63 1686 713 541 3 -1610 1598 1027 748 3 -1118 474 1016 1866 3 -799 484 600 1413 3 -1052 1446 1394 647 3 -599 1225 1052 1446 3 -1405 484 1413 793 3 -904 1700 1727 1550 3 -1594 1606 1603 1461 3 -1383 1047 998 1301 3 -1444 1576 1234 1774 3 -1644 1491 1562 1625 3 -1773 1635 565 345 3 -1428 1181 1779 1301 3 -553 1021 1563 676 3 -1268 1492 1606 1594 3 -1836 227 665 1271 3 -1498 1039 932 359 3 -1916 1734 1813 1907 3 -1470 1248 1635 383 3 -171 1870 736 1428 3 -1920 1730 327 1892 3 -1715 83 935 1062 3 -1130 1822 1945 1414 3 -1057 820 1432 1579 3 -1559 571 1427 1660 3 -700 574 662 753 3 -1603 1209 395 1463 3 -1671 904 1619 1727 3 -1671 1619 1382 1727 3 -985 1619 1382 1671 3 -150 682 1541 179 3 -882 1089 601 1164 3 -432 1577 622 321 3 -432 1577 321 456 3 -732 1146 552 1311 3 -1424 1373 1650 1656 3 -1434 607 1337 1327 3 -171 52 736 1870 3 -1359 1104 555 1434 3 -1427 692 1559 915 3 -800 1777 1151 1423 3 -1151 1777 896 1423 3 -1197 691 133 62 3 -1799 404 1379 405 3 -1689 766 107 716 3 -448 1412 1766 44 3 -505 615 540 517 3 -1245 1103 1154 1381 3 -1853 1477 1159 1538 3 -470 1001 1419 322 3 -555 1776 579 1365 3 -773 439 769 1874 3 -1289 620 1801 785 3 -1250 935 1389 1715 3 -1184 1801 602 1564 3 -1177 946 795 537 3 -824 818 14 479 3 -793 1421 1413 1405 3 -1666 1655 1471 1503 3 -732 1146 1311 720 3 -1521 1009 1504 545 3 -984 1085 1422 784 3 -1726 524 1693 160 3 -1401 638 1684 1475 3 -1434 1423 1327 1337 3 -896 1151 1423 1337 3 -1858 1758 686 430 3 -1606 1530 776 366 3 -1327 1423 642 753 3 -1376 1423 642 1327 3 -1529 1845 684 414 3 -324 631 1613 835 3 -992 816 1547 937 3 -946 863 800 1423 3 -1606 1530 366 1461 3 -585 1660 1728 1778 3 -537 753 1423 795 3 -537 753 642 1423 3 -1381 1678 1585 1681 3 -537 853 946 1423 3 -1670 1643 1243 1746 3 -39 1423 946 800 3 -39 795 946 1423 3 -1284 1145 139 763 3 -1419 492 1001 443 3 -1378 1794 1377 1644 3 -613 1106 530 1062 3 -751 352 142 1100 3 -558 810 1211 1948 3 -464 429 1796 1890 3 -1877 122 722 743 3 -1314 1082 1196 641 3 -1930 477 448 653 3 -744 193 725 1080 3 -1010 1775 1672 1252 3 -717 1616 1817 136 3 -900 692 58 837 3 -1568 1702 1954 496 3 -1724 360 1039 359 3 -1609 1063 522 1927 3 -1841 1929 382 1471 3 -1383 1779 567 954 3 -1540 1753 1773 1779 3 -1946 1265 1464 1956 3 -902 1940 1043 954 3 -1404 1821 930 1477 3 -1231 346 1877 1942 3 -1917 386 1098 1190 3 -97 371 1206 847 3 -1779 1181 1047 1301 3 -567 1540 1779 1753 3 -1385 599 1052 1446 3 -914 772 494 1589 3 -526 1497 221 1818 3 -1539 423 1087 1861 3 -876 1431 1173 989 3 -876 1226 1431 989 3 -1940 435 897 922 3 -1768 1542 1495 810 3 -983 533 1526 1527 3 -820 949 938 1432 3 -631 1161 1308 1535 3 -209 976 431 788 3 -661 1702 1893 553 3 -751 1318 674 184 3 -1223 819 1433 1030 3 -1223 1433 1033 1417 3 -1223 819 1033 1433 3 -1871 286 741 856 3 -1202 1921 1794 1068 3 -1911 850 2 1941 3 -963 1395 760 672 3 -510 1602 56 1502 3 -818 1690 160 1349 3 -1833 701 645 1025 3 -396 745 466 1954 3 -815 1623 717 478 3 -1120 1067 155 771 3 -1212 1946 1855 1730 3 -1379 1414 1605 1945 3 -1454 1372 1590 1303 3 -491 1667 677 1741 3 -1608 1907 483 1681 3 -1307 1184 1528 1564 3 -853 1631 1733 586 3 -151 1383 998 1301 3 -404 1111 799 405 3 -1157 1122 1537 1179 3 -616 407 408 1826 3 -1267 1029 1142 749 3 -917 22 1375 1462 3 -1848 1791 1081 814 3 -1927 1063 522 569 3 -1252 1547 993 816 3 -1760 1389 588 1364 3 -1925 860 418 1467 3 -1436 1168 1723 874 3 -1866 2 1941 1911 3 -716 1465 1453 581 3 -581 41 1453 564 3 -1214 770 1447 1756 3 -1547 1438 1775 1252 3 -1515 601 1438 1482 3 -1793 921 17 487 3 -482 979 1252 513 3 -482 1003 979 513 3 -17 1793 1675 921 3 -1294 42 1373 1656 3 -1727 1619 1700 904 3 -234 40 1082 283 3 -1209 1260 395 548 3 -1444 824 14 479 3 -1338 1384 1804 1654 3 -876 1431 1561 338 3 -923 9 1243 1784 3 -876 1431 338 1173 3 -316 1434 1104 1359 3 -306 1374 774 931 3 -1690 1693 160 1096 3 -1214 770 1756 695 3 -355 1947 386 966 3 -630 497 1086 855 3 -1947 1708 1039 460 3 -714 1547 740 937 3 -557 1483 1802 514 3 -1112 1548 855 1324 3 -1544 1700 1720 1090 3 -1048 381 841 1580 3 -886 664 1444 479 3 -765 1361 1721 954 3 -432 1501 622 1577 3 -1444 1187 824 1361 3 -153 1146 720 409 3 -153 743 1146 409 3 -1804 1338 1834 1704 3 -457 1354 1502 549 3 -850 474 558 905 3 -1663 805 1872 835 3 -1211 1941 474 558 3 -1438 1636 3 1355 3 -200 314 769 773 3 -1626 610 1784 1552 3 -1710 603 1662 1174 3 -605 415 795 1103 3 -1483 1622 1802 514 3 -876 1757 1883 23 3 -526 1497 158 221 3 -499 1104 1752 1809 3 -1757 1424 428 1492 3 -1389 1290 1364 1760 3 -1642 49 1754 1593 3 -840 1245 833 1486 3 -743 27 1146 409 3 -1937 1474 1592 1528 3 -740 1599 1010 1775 3 -310 1359 1467 224 3 -1004 591 1671 1478 3 -348 1073 1339 999 3 -599 1225 1446 1106 3 -1804 1384 1210 1654 3 -71 1391 1696 1810 3 -1079 797 975 1286 3 -593 1240 531 861 3 -864 1225 1106 1446 3 -377 1474 951 1544 3 -1857 1307 1306 1037 3 -765 1187 1439 1576 3 -844 442 1612 447 3 -799 484 3 600 3 -1486 801 833 1217 3 -1225 864 1394 1446 3 -1283 1763 636 350 3 -403 1225 1106 864 3 -1041 714 1898 740 3 -1688 668 1457 1495 3 -1385 1954 1825 959 3 -1288 1045 1857 1037 3 -1473 1064 254 704 3 -1187 1576 1444 14 3 -1439 1576 887 1181 3 -1525 946 1103 1177 3 -855 1124 1548 33 3 -928 42 1193 748 3 -443 492 1001 1304 3 -1273 1272 727 1553 3 -1477 1531 1282 1072 3 -683 1629 1076 618 3 -1324 1548 597 196 3 -1264 1358 474 1866 3 -334 516 161 101 3 -727 334 889 640 3 -1325 1212 956 909 3 -1443 1886 864 1472 3 -1866 1358 474 1941 3 -1604 1794 938 1378 3 -857 908 1081 1848 3 -1057 1313 1502 1136 3 -1853 750 760 563 3 -845 575 1730 328 3 -1639 1810 1325 1433 3 -672 750 760 1853 3 -1929 251 47 211 3 -892 632 65 1312 3 -630 1086 339 1324 3 -259 439 228 1117 3 -738 1057 1060 1704 3 -1204 1123 364 892 3 -1900 491 1560 1667 3 -1551 1201 625 676 3 -339 125 1112 1369 3 -1866 2 1358 1941 3 -1861 423 410 1539 3 -1513 1757 1614 1883 3 -1227 1652 1510 93 3 -1233 1407 1241 1662 3 -617 1164 1293 598 3 -886 1723 479 1458 3 -874 1458 886 882 3 -946 1177 1733 853 3 -787 1494 650 1620 3 -1458 509 479 882 3 -1458 882 479 886 3 -1461 366 1840 1089 3 -33 942 1320 1241 3 -376 1460 1849 1003 3 -376 374 1849 1460 3 -368 394 94 1529 3 -376 792 1003 799 3 -602 1644 1378 1031 3 -638 1382 532 950 3 -989 1824 876 1002 3 -553 1637 1021 676 3 -571 1427 837 58 3 -553 1085 1637 676 3 -121 315 1334 831 3 -1691 1266 976 650 3 -910 861 576 668 3 -502 1357 1203 293 3 -1062 935 1668 1290 3 -653 1470 1865 1422 3 -1401 1221 1186 715 3 -1772 769 255 200 3 -902 1459 298 1940 3 -1005 1266 976 1691 3 -1005 1691 1673 61 3 -776 1107 366 1490 3 -316 607 1434 1188 3 -1305 316 454 375 3 -1777 1517 1038 1213 3 -908 857 1081 1354 3 -857 1081 1354 681 3 -665 1168 874 1784 3 -937 816 740 572 3 -840 833 406 1486 3 -1627 1754 704 1532 3 -258 1061 1321 363 3 -672 750 1395 760 3 -71 1236 1391 1345 3 -1525 1177 1103 612 3 -1887 974 828 1341 3 -547 821 92 1472 3 -727 516 1272 334 3 -1284 763 139 1906 3 -585 1778 1728 1855 3 -1049 369 1344 1782 3 -902 1459 1940 664 3 -1525 924 946 1177 3 -677 491 1900 1667 3 -562 413 520 678 3 -902 1940 954 664 3 -556 1678 1381 1154 3 -1381 1678 556 1585 3 -1070 1795 764 1524 3 -1143 1042 1113 1382 3 -965 734 849 555 3 -1861 1688 980 785 3 -623 706 823 693 3 -1246 1158 426 1077 3 -1447 770 555 1756 3 -815 783 1542 1623 3 -1670 1805 621 19 3 -1707 669 1092 1884 3 -782 1463 1603 1628 3 -139 1443 547 1145 3 -689 1482 604 611 3 -347 403 1443 864 3 -320 1676 1001 1304 3 -1555 1293 1158 285 3 -624 975 1519 1623 3 -1789 1471 1516 1401 3 -548 1088 1260 395 3 -605 1740 727 415 3 -18 756 651 1519 3 -1087 785 1861 980 3 -710 1828 1218 1070 3 -1169 1319 1935 263 3 -1857 694 1764 807 3 -1252 1448 1379 979 3 -1535 1697 323 730 3 -639 1713 1561 1424 3 -1339 417 1094 166 3 -689 1293 1723 1458 3 -453 1539 423 336 3 -321 320 1053 492 3 -1705 207 80 1188 3 -1691 193 1160 1080 3 -1314 1338 1834 1804 3 -1484 1933 1628 655 3 -392 126 1476 391 3 -1577 456 492 321 3 -1070 1710 1174 1608 3 -985 1488 1824 585 3 -213 809 1453 862 3 -1381 1469 483 39 3 -1215 688 1940 34 3 -438 1729 1909 1699 3 -1585 1381 840 556 3 -1678 1445 1562 1585 3 -1268 1916 1813 1463 3 -803 1134 1368 1504 3 -1844 1428 1301 1904 3 -527 617 479 780 3 -763 696 1703 1906 3 -381 1390 1048 841 3 -856 41 1465 581 3 -1585 1486 1562 556 3 -588 1504 1134 944 3 -1504 554 803 944 3 -1042 1712 846 1700 3 -1765 1918 1868 1478 3 -921 1829 1207 1918 3 -537 642 853 1423 3 -1517 1213 948 1038 3 -1213 863 554 1038 3 -147 1048 841 1580 3 -1102 1118 1405 1569 3 -1024 1556 672 1477 3 -1233 1407 1662 1660 3 -622 353 120 1934 3 -1483 1196 911 1571 3 -745 496 945 1026 3 -610 882 888 1452 3 -1202 1794 1604 1378 3 -22 1536 1928 938 3 -917 543 544 1375 3 -1688 810 1495 1457 3 -1940 688 216 34 3 -430 686 635 493 3 -1178 1251 633 1845 3 -20 1299 1797 910 3 -1847 1735 1751 585 3 -1184 793 1484 1068 3 -1771 211 251 382 3 -1187 777 1439 1658 3 -1463 1445 501 1678 3 -1392 920 1876 789 3 -139 1443 821 547 3 -1955 678 1132 559 3 -676 1551 1563 289 3 -613 84 632 530 3 -811 1512 1710 1407 3 -543 22 893 1375 3 -144 46 1588 790 3 -1427 948 566 837 3 -1660 1847 1728 571 3 -566 1270 943 1192 3 -1215 1880 34 1940 3 -1523 1164 1158 1293 3 -1639 506 1101 895 3 -1439 1576 1181 1047 3 -1645 1796 1763 5 3 -902 1043 1549 954 3 -198 689 611 1555 3 -308 1572 756 1274 3 -1648 1716 341 1418 3 -705 1113 1308 1475 3 -945 984 65 1751 3 -548 1088 1732 1260 3 -1523 1293 1158 1555 3 -689 1458 1523 1293 3 -1555 689 1523 1293 3 -1482 601 1158 1523 3 -693 737 523 1781 3 -1874 439 1117 228 3 -1595 1170 1380 566 3 -50 57 940 1850 3 -527 479 1349 780 3 -1800 1148 1818 629 3 -1759 817 438 426 3 -1437 76 1182 1956 3 -828 1395 899 1887 3 -1522 1660 1233 1488 3 -1493 590 1891 470 3 -84 1674 1831 599 3 -1789 1589 1671 623 3 -1694 76 1464 906 3 -1825 1954 927 959 3 -168 197 1587 47 3 -297 307 1939 1842 3 -1161 1023 16 1298 3 -44 448 1201 854 3 -914 1589 1382 1789 3 -625 1412 1201 825 3 -1551 1201 1021 1007 3 -1612 1250 1389 442 3 -627 1317 1149 559 3 -43 1800 192 1497 3 -883 1497 1247 43 3 -883 158 1497 43 3 -1263 449 1885 781 3 -1688 602 980 1801 3 -319 449 333 1885 3 -1247 1375 1800 1497 3 -1688 1801 980 785 3 -1252 1905 536 816 3 -1842 1353 297 215 3 -117 823 159 252 3 -340 1186 1049 1899 3 -1944 859 1288 15 3 -1548 855 33 1494 3 -1497 707 36 629 3 -1499 315 1820 447 3 -1449 888 872 1435 3 -351 1596 1819 159 3 -706 1819 823 252 3 -119 1885 319 333 3 -1801 1087 980 785 3 -1233 1662 1597 1698 3 -1529 1679 95 684 3 -351 1819 1655 252 3 -1227 1906 85 1510 3 -1655 1596 1789 1819 3 -706 1655 1819 252 3 -894 1888 416 1034 3 -1170 1614 1662 1660 3 -1213 1270 1737 1795 3 -297 1939 1303 1842 3 -1033 819 1565 1399 3 -1124 497 819 33 3 -740 1599 1775 1455 3 -64 1032 1493 74 3 -1427 1170 1407 1660 3 -1501 432 622 1420 3 -1087 785 709 1861 3 -666 1404 1936 930 3 -1068 507 1644 1495 3 -1389 1833 645 1156 3 -422 1822 421 1130 3 -1691 1005 1160 193 3 -308 1572 997 756 3 -1589 582 985 848 3 -715 772 914 623 3 -422 451 1822 1130 3 -825 1915 713 1201 3 -1535 583 705 1285 3 -813 1731 157 1506 3 -615 1289 1564 999 3 -1200 289 676 1563 3 -661 289 1563 201 3 -1918 472 1097 1765 3 -1029 1448 1507 674 3 -809 1194 187 1558 3 -809 213 1862 1558 3 -296 205 1761 258 3 -1620 942 1432 1494 3 -813 1506 157 1227 3 -1494 949 1432 787 3 -1494 626 942 949 3 -942 949 1432 1494 3 -902 954 1549 664 3 -1938 179 1903 1361 3 -650 787 1028 1494 3 -778 1821 1072 1531 3 -1385 1946 575 959 3 -695 1104 555 1359 3 -4 1118 1866 1264 3 -1537 1716 1508 1648 3 -991 1733 853 925 3 -477 1661 1481 1412 3 -515 925 1631 176 3 -125 1410 1180 1894 3 -297 307 239 1939 3 -1020 569 786 1670 3 -1811 861 708 910 3 -334 1593 762 1642 3 -1045 1764 1037 505 3 -551 1199 414 1251 3 -1078 1734 1813 1916 3 -1181 1904 521 1301 3 -1529 1859 1679 1346 3 -1739 282 1374 1534 3 -1756 770 555 695 3 -1250 79 1389 935 3 -339 891 1112 1324 3 -983 533 1904 677 3 -1526 1527 162 358 3 -1037 1320 626 1937 3 -845 1265 1464 1730 3 -1400 1239 755 1013 3 -1652 92 1906 1510 3 -359 1498 1725 1541 3 -723 969 1578 58 3 -588 944 973 903 3 -1345 1391 71 1121 3 -1773 1753 1132 383 3 -1599 1216 1262 1550 3 -1934 1177 1949 1300 3 -1722 1701 1262 1775 3 -1675 901 485 1557 3 -1768 1068 1664 793 3 -232 1739 1374 1783 3 -1817 1011 1371 875 3 -1248 533 1837 1904 3 -733 871 1516 950 3 -1907 1524 1469 768 3 -811 1517 1835 1297 3 -608 1642 727 934 3 -1379 1414 799 1605 3 -1481 1661 1189 625 3 -1661 1129 625 676 3 -1261 858 1209 1199 3 -1010 1216 1142 1672 3 -1663 185 1335 805 3 -603 811 1297 1710 3 -1614 1662 1660 1233 3 -507 1664 1393 538 3 -1519 651 1491 1623 3 -18 651 1491 1519 3 -1519 975 651 1623 3 -1597 1790 1172 881 3 -109 1115 485 1520 3 -485 596 1520 1232 3 -306 1374 1783 232 3 -1025 645 1889 65 3 -510 1839 471 1607 3 -1779 1248 1181 1428 3 -1355 817 1953 1687 3 -1553 1685 415 833 3 -1383 170 736 1198 3 -1047 521 1181 1439 3 -1264 2 1358 1866 3 -679 1627 1816 49 3 -468 1102 1413 1926 3 -1522 1033 1143 951 3 -1185 1033 1143 1522 3 -1614 1698 1233 1488 3 -1582 803 946 924 3 -1224 726 992 721 3 -1129 1422 653 1865 3 -539 1877 1093 659 3 -1908 280 1442 10 3 -1532 573 1255 1217 3 -1532 573 1217 756 3 -82 599 1052 1385 3 -979 1605 1672 1448 3 -736 1428 1779 1301 3 -1433 1059 1143 452 3 -1740 1273 415 1245 3 -1759 391 817 426 3 -1522 1233 1814 1488 3 -1814 1720 1488 1780 3 -1467 1359 695 1756 3 -474 905 538 1768 3 -1368 1504 1524 803 3 -1270 867 1038 1737 3 -1276 1044 455 898 3 -1042 951 1298 1712 3 -1395 1692 672 899 3 -1209 776 1603 1260 3 -944 1364 1504 1737 3 -944 1737 1504 554 3 -800 863 554 1213 3 -1627 573 1255 1532 3 -1530 1089 1490 366 3 -1879 1316 1905 721 3 -389 444 1285 1344 3 -1371 878 1817 1856 3 -181 700 574 657 3 -1088 1426 768 1803 3 -1154 1088 768 1803 3 -1154 1525 1803 1469 3 -1421 1528 1184 618 3 -451 1130 1872 1926 3 -1421 1307 1184 1528 3 -497 495 819 1565 3 -804 1066 1802 885 3 -499 1239 1104 1809 3 -1896 1764 1801 1307 3 -385 384 1236 489 3 -882 1089 1530 1452 3 -1024 1531 1282 1477 3 -643 335 1374 1745 3 -863 586 944 1788 3 -483 800 1777 1151 3 -570 652 1531 1206 3 -1010 1775 1252 816 3 -890 256 931 1534 3 -1514 1403 728 1051 3 -776 1531 1282 1024 3 -1531 652 818 1206 3 -1695 652 1024 1531 3 -1332 1488 1780 23 3 -627 38 413 1317 3 -878 1480 752 246 3 -1013 480 418 1888 3 -575 1954 959 1568 3 -1867 1851 472 1194 3 -1187 1749 777 1541 3 -683 1507 1076 1430 3 -396 745 1954 1702 3 -651 573 18 641 3 -1235 890 643 1534 3 -385 1236 956 489 3 -890 256 1534 687 3 -1032 1156 449 781 3 -449 1056 445 1156 3 -449 1156 1416 781 3 -1899 1812 340 834 3 -232 282 1374 1739 3 -989 904 1173 1824 3 -928 1947 1584 1190 3 -1772 569 769 1063 3 -1348 1534 996 72 3 -1628 1484 1744 1546 3 -779 700 662 1352 3 -759 1416 342 1826 3 -1757 1492 1268 1594 3 -1282 776 14 1490 3 -331 1942 1430 539 3 -185 1238 1335 694 3 -489 384 1236 906 3 -1078 1734 1174 1813 3 -694 1238 1335 1926 3 -1653 1645 1878 1750 3 -483 1710 1777 764 3 -1852 813 157 93 3 -1906 92 1652 1472 3 -928 1039 1498 1947 3 -9 902 664 1436 3 -917 1375 544 1800 3 -353 1934 622 1420 3 -1070 1078 1828 1734 3 -185 1335 805 694 3 -1355 1687 3 712 3 -1613 1288 1857 1306 3 -1525 1582 1469 946 3 -1555 1158 1476 285 3 -495 505 1037 626 3 -1097 1727 1671 950 3 -907 173 162 529 3 -1754 833 660 1217 3 -627 88 1317 559 3 -1640 730 1535 583 3 -562 1588 1171 144 3 -1770 1501 731 443 3 -694 1335 805 1926 3 -596 1067 218 1179 3 -562 1540 520 567 3 -881 1474 1544 1665 3 -1138 721 1316 212 3 -290 1893 1568 135 3 -1685 1754 1816 406 3 -717 1411 1286 775 3 -275 990 1310 849 3 -1437 956 1391 1236 3 -1340 257 990 849 3 -1704 1338 1398 1060 3 -738 1704 1060 1384 3 -882 1530 888 1452 3 -470 1419 1493 590 3 -143 190 804 885 3 -1267 1029 552 1142 3 -9 665 902 1436 3 -938 1057 1704 1377 3 -1384 1536 738 1704 3 -675 1203 1567 294 3 -94 1480 1792 129 3 -977 505 495 497 3 -885 1802 514 208 3 -1957 71 59 1433 3 -1944 859 730 1288 3 -622 1676 1304 120 3 -919 1688 980 1861 3 -1608 1734 764 483 3 -553 1637 1026 1050 3 -1612 1156 1009 1389 3 -602 1495 1031 1688 3 -1660 969 571 1728 3 -584 831 1334 176 3 -1777 764 800 483 3 -77 488 502 1876 3 -993 1547 992 816 3 -993 610 992 1547 3 -1110 921 1675 1291 3 -1050 553 1637 1021 3 -1085 1637 673 784 3 -448 1637 1021 854 3 -64 590 1493 1055 3 -1876 913 1357 293 3 -1816 1338 894 755 3 -1218 1600 1368 768 3 -1124 1324 1548 597 3 -260 1411 1817 717 3 -925 176 515 182 3 -1687 1759 1860 1763 3 -1691 1832 461 650 3 -683 1430 1076 835 3 -1687 1759 1763 1269 3 -886 664 1549 1444 3 -1549 902 664 9 3 -886 9 664 1436 3 -1325 969 1212 909 3 -1311 188 852 1581 3 -285 1555 1165 1228 3 -1466 1425 870 723 3 -1596 1401 1471 1789 3 -1383 1047 1215 998 3 -1522 1185 1660 1778 3 -977 1140 1045 505 3 -461 1548 1494 1028 3 -26 719 107 1689 3 -1228 1555 126 285 3 -1774 1576 1350 1109 3 -1228 611 126 1555 3 -610 888 874 1552 3 -608 1642 1553 727 3 -82 1052 637 1441 3 -1907 768 1469 1154 3 -654 129 1792 878 3 -758 723 1325 909 3 -1939 1280 1274 801 3 -1516 1671 1382 950 3 -1175 1472 965 867 3 -1341 1887 974 1420 3 -318 491 1917 1863 3 -915 1176 1241 1407 3 -1392 920 796 1876 3 -1598 928 1193 748 3 -482 1476 1292 611 3 -329 1618 1086 630 3 -1346 1859 947 1910 3 -401 420 379 400 3 -181 657 68 779 3 -1260 1556 672 1024 3 -1260 776 1556 1024 3 -142 513 352 751 3 -1696 1437 1182 909 3 -1794 820 938 1377 3 -1202 1068 1378 602 3 -153 720 732 718 3 -820 1579 1377 1794 3 -1677 1440 1009 1612 3 -1650 1439 1741 1658 3 -1378 1644 1377 1210 3 -1439 1741 1658 777 3 -1213 1795 1737 554 3 -1377 1210 1644 1625 3 -1074 1586 839 851 3 -1068 507 1393 1644 3 -507 1495 1491 1644 3 -1658 1741 1584 777 3 -1033 1559 1399 377 3 -1033 1814 1559 377 3 -914 1143 494 452 3 -1054 1478 1765 382 3 -377 1233 1814 1559 3 -973 387 470 1820 3 -1220 975 270 1408 3 -1238 987 694 423 3 -1841 1471 382 1666 3 -1076 1629 1421 618 3 -185 694 805 807 3 -1194 761 17 901 3 -1711 1934 353 1420 3 -1236 956 1345 385 3 -1098 1190 1632 748 3 -1554 1394 347 1443 3 -1639 758 1325 1810 3 -1586 175 794 1074 3 -402 1909 371 1699 3 -1934 1177 443 1711 3 -507 1562 1491 783 3 -1562 18 1491 1519 3 -1486 18 1562 1519 3 -715 1347 159 1767 3 -33 942 1620 1494 3 -761 596 1067 771 3 -1345 1121 446 370 3 -16 1023 1712 1298 3 -987 1575 1184 980 3 -589 1058 842 940 3 -1409 1910 801 1500 3 -1861 424 709 154 3 -992 721 816 572 3 -1722 1090 655 1747 3 -1227 1586 794 362 3 -603 811 1057 1835 3 -667 419 828 1133 3 -910 861 668 1811 3 -1840 1687 3 1636 3 -576 861 1031 668 3 -666 760 963 1936 3 -365 1362 1752 555 3 -361 1811 708 220 3 -78 1183 503 1200 3 -657 574 537 662 3 -991 657 662 779 3 -973 803 1733 586 3 -965 1703 1362 696 3 -139 821 92 547 3 -1621 91 690 408 3 -278 1927 1772 200 3 -1320 1033 1023 1565 3 -1143 1113 1684 1382 3 -888 874 886 882 3 -1608 1710 1174 603 3 -1102 1238 1926 8 3 -959 1026 1855 1568 3 -1391 1325 956 909 3 -1606 776 1603 366 3 -1695 1699 1283 703 3 -220 1571 303 281 3 -1575 987 1184 1421 3 -1019 636 538 350 3 -911 1571 812 1489 3 -1489 1302 1571 281 3 -1489 1302 911 1571 3 -1813 1678 1681 1445 3 -220 910 303 1571 3 -1171 1383 170 1588 3 -1582 1368 924 1426 3 -424 1811 361 595 3 -1740 868 1273 500 3 -153 1146 1267 732 3 -837 948 1511 1427 3 -923 1243 769 1117 3 -1020 769 255 1772 3 -769 1874 1115 255 3 -1020 769 1115 255 3 -1763 1358 1269 1309 3 -64 1098 1249 1769 3 -196 1369 1548 433 3 -153 732 1267 535 3 -474 1405 1575 793 3 -334 889 161 1272 3 -1363 1016 987 1575 3 -1263 1881 1885 1560 3 -611 1482 1476 1523 3 -1184 1575 602 980 3 -1184 793 602 1575 3 -1419 1001 470 973 3 -378 534 1336 1208 3 -571 837 566 647 3 -571 1427 566 837 3 -971 332 834 733 3 -1174 1662 1172 603 3 -1425 1441 577 1578 3 -1157 1867 1537 1122 3 -765 1444 1187 1576 3 -1054 1765 1097 1851 3 -314 1328 1063 923 3 -1570 1707 1435 1244 3 -908 1034 857 1354 3 -1215 1047 765 998 3 -536 830 1100 184 3 -1744 1089 1461 1840 3 -1692 432 456 1577 3 -571 58 837 1578 3 -1364 1731 1506 356 3 -900 837 58 1578 3 -726 1879 1905 721 3 -1559 1427 571 58 3 -1621 91 408 616 3 -1503 1004 1671 1478 3 -393 1011 429 875 3 -1391 956 1121 1345 3 -1570 1707 565 1435 3 -1695 12 1283 1699 3 -1503 1235 1004 1745 3 -1264 1358 1269 712 3 -424 1688 785 861 3 -1811 595 1071 361 3 -1678 1445 1585 1681 3 -1681 1625 1579 1445 3 -1765 862 809 382 3 -1575 919 1363 1211 3 -564 1871 41 229 3 -1917 966 386 1190 3 -1207 1453 1868 581 3 -382 1478 1868 1131 3 -762 1593 480 375 3 -363 1163 1167 857 3 -1600 1426 1368 768 3 -1513 1583 953 1380 3 -1583 587 1025 1521 3 -1380 1583 1025 1521 3 -1025 1583 1380 953 3 -1025 587 1583 953 3 -1939 663 1303 1274 3 -1366 1930 989 1370 3 -1009 1389 588 1612 3 -964 1039 1854 1282 3 -866 1687 1763 1269 3 -1899 733 834 168 3 -774 1007 1201 1806 3 -711 202 268 1064 3 -716 921 1675 1153 3 -914 494 582 1589 3 -17 921 1918 487 3 -17 1207 472 1918 3 -454 607 316 1188 3 -1314 1082 1654 1483 3 -487 1918 436 1478 3 -921 1829 1918 487 3 -1288 859 1613 15 3 -1918 1829 1868 1478 3 -903 794 1586 175 3 -903 1506 586 1586 3 -839 1586 1376 851 3 -1074 175 839 1586 3 -294 1145 1554 1443 3 -644 1586 851 1376 3 -1888 1925 1013 1034 3 -1587 169 168 47 3 -733 169 168 1587 3 -1034 1354 1450 549 3 -572 937 1041 740 3 -1477 1556 672 1610 3 -1273 868 1272 210 3 -1036 1900 119 1526 3 -1809 1104 1752 695 3 -837 692 1511 577 3 -1171 144 1588 170 3 -1023 568 1640 730 3 -1425 1387 577 1567 3 -101 516 528 54 3 -704 1553 1590 660 3 -704 1553 516 1590 3 -1152 1278 1818 1148 3 -516 528 54 1590 3 -1180 325 1894 1410 3 -516 1272 1590 1553 3 -1481 383 1132 1017 3 -857 1451 1848 1167 3 -69 658 99 762 3 -565 345 1234 1707 3 -528 1372 271 1590 3 -1361 1903 1938 435 3 -1842 307 1939 1280 3 -207 1188 454 1296 3 -239 663 1303 1939 3 -664 1361 1940 954 3 -239 238 1939 307 3 -224 311 1467 244 3 -981 471 510 1511 3 -981 1175 471 1511 3 -1398 1057 1579 1704 3 -603 811 1835 1297 3 -1704 1057 1579 1377 3 -65 632 1595 530 3 -943 1595 1446 530 3 -518 1573 1876 1791 3 -1870 52 736 606 3 -1607 1839 1081 56 3 -463 460 1039 1708 3 -1170 566 1595 571 3 -249 1305 454 762 3 -547 92 1906 1472 3 -1854 1039 932 1498 3 -1672 683 1605 618 3 -868 500 912 48 3 -1359 1467 1305 310 3 -770 1752 555 695 3 -882 874 601 610 3 -850 474 1358 1941 3 -915 1512 692 510 3 -1484 1090 655 1722 3 -1618 495 568 1276 3 -1633 665 1168 1342 3 -826 620 348 167 3 -504 658 1593 480 3 -1919 1510 85 1906 3 -881 1597 1790 1933 3 -801 1519 1486 1500 3 -1767 1782 370 369 3 -288 1020 255 1772 3 -1230 1429 1716 1169 3 -1113 1042 1298 532 3 -1208 1173 1449 1040 3 -1945 421 1799 405 3 -1308 532 1298 16 3 -623 1503 1671 1789 3 -1862 1689 1453 1194 3 -1550 1173 1449 1208 3 -1709 1682 1681 1585 3 -881 1597 1933 1780 3 -1712 525 1544 1474 3 -1338 573 1314 1255 3 -1702 945 496 553 3 -1338 1035 1654 1314 3 -1135 172 606 156 3 -1267 1146 552 732 3 -1257 1735 693 848 3 -659 852 552 1146 3 -512 1754 516 704 3 -822 198 1065 611 3 -1215 998 765 767 3 -1199 1750 636 350 3 -930 1261 1750 1199 3 -1118 1405 987 1575 3 -765 1361 1444 1721 3 -1215 1383 34 1880 3 -1199 1261 1750 350 3 -1564 1202 1604 1378 3 -1014 1569 1363 1016 3 -298 1940 216 34 3 -757 1514 1155 1126 3 -1207 1194 1765 1453 3 -1361 664 1444 1721 3 -1063 245 1328 314 3 -1877 1146 971 659 3 -1449 872 1570 1435 3 -483 1524 1469 1907 3 -1478 1666 1503 1745 3 -1202 1484 1921 1068 3 -1357 1607 471 913 3 -1606 986 1530 1461 3 -1594 986 1606 1461 3 -1037 1764 1307 1937 3 -1357 913 471 933 3 -765 767 998 1749 3 -1607 1137 1279 510 3 -789 1607 1279 510 3 -1607 656 1279 1137 3 -1607 1081 656 1137 3 -1614 1233 1660 1488 3 -1707 1540 1092 669 3 -1792 1480 1367 878 3 -1792 1367 1630 878 3 -380 870 399 1390 3 -536 1418 732 1029 3 -927 959 1847 1825 3 -856 41 581 1871 3 -1609 245 522 1063 3 -463 1708 1039 1610 3 -1255 1338 1816 1834 3 -1121 956 494 914 3 -4 1162 1118 1569 3 -706 1503 1655 1348 3 -1118 1405 1575 474 3 -483 1524 800 1469 3 -1644 373 1210 668 3 -1070 1710 1608 764 3 -1047 998 521 1749 3 -1564 1378 1928 1289 3 -1611 1713 1912 953 3 -1608 1813 1907 1681 3 -458 908 1034 857 3 -1742 1884 1670 786 3 -1381 483 1709 39 3 -1370 669 1884 1110 3 -19 1707 1092 1884 3 -397 745 1123 466 3 -1493 1419 1615 1055 3 -706 1503 1348 1235 3 -1370 1884 1291 1110 3 -1513 1757 1713 710 3 -1608 483 1297 1681 3 -1424 1600 710 1828 3 -1784 604 689 874 3 -801 1273 833 660 3 -471 981 1703 1175 3 -764 1070 1524 1734 3 -378 904 487 436 3 -220 1811 1071 361 3 -1224 1319 721 572 3 -1029 184 535 536 3 -1432 820 942 1172 3 -229 286 199 685 3 -1871 41 229 286 3 -1140 1764 1045 505 3 -1947 1190 386 966 3 -1639 819 1399 952 3 -1385 575 1954 959 3 -1140 615 1932 505 3 -220 910 1571 1646 3 -149 640 762 607 3 -884 391 1269 1759 3 -1182 1956 723 909 3 -995 702 1135 383 3 -575 1568 1946 1730 3 -702 172 1135 73 3 -1432 820 1172 1579 3 -597 952 1324 1403 3 -259 439 314 773 3 -1536 1377 1378 938 3 -585 1488 1824 1883 3 -1932 615 1564 505 3 -1764 1932 1564 505 3 -373 1483 1210 668 3 -149 640 607 739 3 -1886 1175 981 1511 3 -1054 1516 1671 1471 3 -1086 497 819 1124 3 -1810 506 1706 982 3 -1682 1816 1398 1834 3 -1064 1627 1545 512 3 -506 1696 758 1810 3 -1858 1621 686 148 3 -1152 1691 1278 1148 3 -843 1485 677 521 3 -952 1126 33 1399 3 -1541 179 1187 767 3 -765 1215 767 1361 3 -1541 767 1187 1749 3 -1541 767 1749 150 3 -150 179 1541 767 3 -458 1116 1451 363 3 -1531 524 360 372 3 -818 524 1531 1206 3 -1773 1540 1823 1707 3 -1812 1535 1308 1344 3 -576 668 1031 1622 3 -1386 991 1300 1949 3 -964 932 1690 1187 3 -1024 776 1531 652 3 -1202 1921 1172 1794 3 -1531 776 1282 1490 3 -1210 1483 1622 668 3 -470 1820 588 973 3 -812 1491 1623 783 3 -1791 276 814 877 3 -1602 1517 365 499 3 -1369 1119 1548 433 3 -1951 745 892 1123 3 -1135 172 156 1237 3 -486 111 940 958 3 -1508 901 1336 1793 3 -486 111 958 514 3 -518 1876 293 1791 3 -1101 381 841 895 3 -592 1751 784 354 3 -12 970 1645 1468 3 -10 1071 220 1646 3 -1571 1646 812 1489 3 -10 1646 220 281 3 -311 274 860 244 3 -109 766 485 1115 3 -917 1375 1247 1462 3 -1594 655 23 1747 3 -722 124 1877 971 3 -826 620 615 348 3 -347 864 1443 1394 3 -1552 1244 1805 1670 3 -1713 592 1513 953 3 -707 1060 629 1313 3 -1508 1557 341 1716 3 -975 797 270 1408 3 -1247 1375 917 1800 3 -341 1041 1191 1716 3 -1618 497 1086 630 3 -1463 1628 1268 1603 3 -1213 1737 1038 554 3 -1161 583 1308 1535 3 -441 807 1932 453 3 -1791 1081 1607 913 3 -1236 956 1391 1345 3 -1524 800 1469 1582 3 -1932 807 1764 423 3 -1147 444 1285 389 3 -1344 1475 1308 1812 3 -1851 1765 809 1054 3 -744 725 544 1832 3 -174 1056 74 1440 3 -1630 1199 1019 427 3 -1251 1199 1630 427 3 -1277 1027 750 1738 3 -551 684 414 368 3 -1862 1689 1194 146 3 -243 273 1451 1167 3 -51 1249 1913 1388 3 -213 107 1862 1558 3 -1392 796 788 1876 3 -445 79 645 1156 3 -1440 1156 1032 1009 3 -1149 1779 1753 567 3 -1612 1440 1156 174 3 -1773 1707 565 669 3 -1030 819 1433 1639 3 -882 1530 1774 888 3 -778 1531 1072 360 3 -1367 1897 1322 478 3 -1532 1754 660 1217 3 -540 543 1073 999 3 -1235 1745 335 643 3 -929 1189 529 493 3 -321 1304 492 1577 3 -321 320 492 1304 3 -321 1676 1304 622 3 -401 850 1911 420 3 -622 1577 1304 321 3 -1907 1469 483 1381 3 -1688 1031 602 1289 3 -1557 1746 1232 1643 3 -1565 1399 33 1320 3 -1208 1291 872 1898 3 -1552 874 886 888 3 -1185 1325 1433 1639 3 -64 754 1493 1032 3 -1639 1325 1559 1185 3 -1033 1639 1559 1185 3 -1033 819 1639 1433 3 -1033 819 1399 1639 3 -1032 1156 1056 449 3 -1484 1664 1628 1921 3 -1793 1508 1557 1898 3 -1068 1664 1921 1393 3 -1921 1664 1628 1393 3 -642 839 1376 80 3 -1639 758 58 1325 3 -494 582 1522 1143 3 -1393 1644 1562 1625 3 -1068 1393 1625 1644 3 -1059 1325 1433 1185 3 -1921 1463 1445 1393 3 -1628 1463 1921 1393 3 -422 421 674 1507 3 -1292 482 1460 1355 3 -907 791 173 529 3 -533 832 907 1527 3 -907 832 791 529 3 -328 575 1730 1568 3 -1791 913 1607 1876 3 -841 1514 488 920 3 -1527 907 162 529 3 -1262 1515 1452 1089 3 -1794 1921 1172 1445 3 -1013 695 1809 1925 3 -1929 1471 809 382 3 -260 1817 875 1402 3 -507 1644 1562 1393 3 -507 1491 1562 1644 3 -1212 1059 494 1185 3 -940 1058 842 486 3 -1442 1489 812 1071 3 -515 1376 853 642 3 -303 1571 1797 557 3 -1918 1336 1097 472 3 -1479 614 1051 147 3 -1216 1142 1648 1010 3 -632 1954 1595 1831 3 -1648 1418 1010 1142 3 -552 1418 1648 1142 3 -1367 1859 752 1830 3 -1382 532 1113 638 3 -534 659 1216 846 3 -852 1157 1648 552 3 -1648 852 1537 1157 3 -534 852 1537 1648 3 -659 852 1648 552 3 -659 852 534 1648 3 -1753 1149 567 1540 3 -1831 1385 1825 1446 3 -1515 1482 993 610 3 -314 1063 769 923 3 -1650 1600 42 1373 3 -756 1274 651 1519 3 -1549 560 19 1721 3 -756 1572 651 1274 3 -1614 1662 1233 1698 3 -1438 1515 993 1547 3 -490 802 42 1373 3 -985 582 1619 1720 3 -501 1897 783 1322 3 -559 1317 1149 678 3 -1287 1204 407 1312 3 -1204 1123 892 632 3 -1878 636 1011 414 3 -1016 1118 987 1575 3 -1750 636 1878 414 3 -1034 363 1321 1061 3 -1023 568 1037 495 3 -1614 1070 1698 1757 3 -1023 1223 1033 1298 3 -951 1023 1033 1298 3 -1041 1898 1746 1557 3 -377 1033 951 1023 3 -1948 1141 104 105 3 -422 749 539 1507 3 -1673 976 209 1691 3 -422 674 749 1507 3 -1858 430 635 248 3 -1058 1654 1384 1338 3 -1058 842 1654 1338 3 -499 1835 1297 1239 3 -230 253 55 646 3 -758 1325 1810 909 3 -1058 1654 36 1384 3 -1058 842 486 1654 3 -1595 632 1831 530 3 -191 43 417 917 3 -1348 1235 335 1534 3 -1835 1602 811 1502 3 -1685 840 406 1682 3 -457 1835 1502 1809 3 -752 1830 1859 1755 3 -567 1588 1149 736 3 -705 1143 452 1417 3 -1831 632 84 530 3 -68 181 1456 657 3 -1400 1434 1104 316 3 -1588 736 567 1383 3 -1853 1072 1159 1477 3 -1256 1686 825 305 3 -969 1660 1559 1185 3 -969 571 1559 1660 3 -1749 998 521 150 3 -64 318 1098 1769 3 -1800 1818 1497 629 3 -1865 832 529 1242 3 -1922 1709 1681 483 3 -1934 1177 1300 443 3 -326 742 440 1330 3 -884 391 1759 426 3 -639 1470 1635 1226 3 -1611 639 1713 953 3 -1687 817 1759 1269 3 -1662 1070 1698 1614 3 -1170 1070 1662 1614 3 -612 550 1711 912 3 -1711 612 1525 550 3 -598 817 1953 1158 3 -64 988 318 1769 3 -1061 458 1116 205 3 -1592 1474 881 1665 3 -1245 1273 833 801 3 -1245 1409 500 801 3 -570 1699 652 371 3 -1053 320 590 492 3 -1216 659 1648 1142 3 -570 1909 1699 371 3 -1695 1699 703 652 3 -1605 1130 1945 1414 3 -1296 1188 1365 302 3 -1273 415 1245 833 3 -1957 962 1875 1657 3 -1666 382 1771 1131 3 -335 1666 1771 1131 3 -945 1026 1751 1847 3 -1864 211 1666 1655 3 -1722 1262 1636 1775 3 -1185 1639 1433 1033 3 -1832 650 1691 1148 3 -1832 725 1800 1080 3 -1667 533 1669 832 3 -650 1832 1028 1148 3 -1190 1947 1632 1708 3 -1288 15 1857 742 3 -1555 1476 126 285 3 -1667 491 1560 1294 3 -490 1190 1098 748 3 -1306 1307 1629 1528 3 -1837 1838 887 1181 3 -540 1882 517 1073 3 -1710 1517 948 1512 3 -1280 752 1859 1755 3 -913 1839 1081 1607 3 -686 1095 1621 635 3 -1752 1104 555 695 3 -1667 53 832 1669 3 -454 316 607 375 3 -1013 1400 1104 316 3 -1814 1233 1698 1488 3 -448 673 1661 1021 3 -1140 615 517 123 3 -832 533 1669 1248 3 -324 323 1613 631 3 -497 505 626 1714 3 -1442 104 10 1638 3 -1208 1599 1508 1898 3 -1172 1597 881 1662 3 -718 184 536 535 3 -82 599 637 1052 3 -608 1642 934 375 3 -1389 1009 588 1504 3 -1709 1685 1922 1682 3 -1415 1651 1140 123 3 -1069 1333 953 1025 3 -1490 1107 366 1089 3 -1262 986 1173 1747 3 -1328 9 621 923 3 -1040 989 904 1173 3 -139 92 1919 1906 3 -1756 1359 555 579 3 -1134 1419 470 973 3 -1817 1542 1046 905 3 -681 1081 1137 656 3 -407 1312 408 1826 3 -280 775 717 1408 3 -1272 1273 210 1590 3 -1584 1190 1947 966 3 -1344 444 1285 1657 3 -1922 1682 755 1398 3 -177 947 974 1139 3 -1599 341 1508 1898 3 -654 129 1371 394 3 -1667 53 1560 832 3 -1424 710 1600 1373 3 -1554 1394 577 398 3 -1063 621 522 569 3 -1124 952 1086 1324 3 -1873 1383 34 1215 3 -912 500 1743 48 3 -761 1675 901 485 3 -639 1470 1838 1635 3 -1861 785 424 1688 3 -17 901 1675 1793 3 -1675 761 17 1207 3 -716 761 1675 1207 3 -761 716 1675 766 3 -761 1675 17 901 3 -1841 197 1587 1596 3 -1896 694 1307 1421 3 -761 485 596 771 3 -761 766 485 771 3 -1216 1943 659 1142 3 -473 850 420 558 3 -137 508 258 1761 3 -823 715 159 1819 3 -992 993 482 611 3 -1079 238 975 797 3 -1238 694 807 423 3 -1268 1628 1790 1786 3 -1218 1912 1583 545 3 -1602 1835 56 1502 3 -484 1264 474 1118 3 -1559 1407 1233 1660 3 -1522 1488 582 585 3 -1720 1522 1814 1488 3 -1814 1720 1780 1544 3 -1606 366 1603 1461 3 -845 1356 575 328 3 -1562 1491 783 1519 3 -550 974 1711 912 3 -89 1149 156 1955 3 -1522 1033 951 1814 3 -633 858 666 551 3 -879 42 1193 928 3 -1785 822 1065 604 3 -1389 442 1760 1612 3 -727 334 640 1642 3 -1065 604 689 1784 3 -874 604 689 1482 3 -1172 1790 1174 1445 3 -1513 1070 1757 710 3 -99 658 98 480 3 -1553 415 1273 833 3 -874 604 1482 610 3 -9 1784 1552 1243 3 -705 827 1657 1285 3 -621 9 1243 923 3 -1188 607 1327 753 3 -1079 1286 752 246 3 -1067 1179 155 218 3 -1038 965 1362 365 3 -1269 391 817 1759 3 -1213 1517 948 1710 3 -954 1880 1940 1043 3 -1179 1429 152 189 3 -1840 1953 1687 1636 3 -41 107 1453 213 3 -1682 1816 1834 406 3 -365 644 1038 1776 3 -963 419 828 667 3 -1517 365 499 896 3 -1821 1695 930 1477 3 -1187 1541 932 1096 3 -1465 107 716 1453 3 -1277 750 459 1738 3 -1588 46 1149 790 3 -1684 1113 1475 638 3 -1357 1876 789 1607 3 -1097 378 436 1727 3 -1844 171 1198 1428 3 -1361 435 824 897 3 -524 818 964 160 3 -752 1859 1367 1280 3 -1773 1540 678 1753 3 -1572 1220 641 651 3 -1571 1483 1797 557 3 -1596 1221 1401 715 3 -1692 1738 456 459 3 -1027 1738 1692 750 3 -1600 1088 1426 768 3 -1444 664 1549 1721 3 -1186 1049 1767 369 3 -136 775 717 1908 3 -1300 121 973 1334 3 -679 1338 842 894 3 -706 687 1348 72 3 -288 1326 134 1020 3 -522 261 1043 217 3 -902 522 1043 217 3 -458 274 1116 205 3 -1442 1908 717 280 3 -1265 1674 1952 82 3 -1085 945 1751 984 3 -841 757 488 1514 3 -1695 1107 652 703 3 -1118 1264 474 1866 3 -489 384 906 1730 3 -757 870 58 895 3 -1730 1265 1464 1946 3 -1787 1380 65 1595 3 -1751 1787 592 984 3 -1883 1488 1332 23 3 -1179 1120 155 189 3 -1007 1806 774 931 3 -73 172 1135 1237 3 -370 1347 1782 1767 3 -481 735 173 791 3 -1695 12 1699 570 3 -793 1484 1546 600 3 -1699 703 402 438 3 -1907 1813 1678 1681 3 -1206 818 524 847 3 -1727 1700 846 1216 3 -275 1296 302 224 3 -1579 1172 603 1445 3 -10 280 1489 281 3 -1742 1291 1670 1884 3 -1031 1644 668 1495 3 -510 1511 471 1362 3 -1791 913 1876 293 3 -808 760 563 1538 3 -876 592 1513 1713 3 -593 531 578 166 3 -1653 1645 464 1878 3 -1788 867 1364 1737 3 -1577 1501 1304 443 3 -717 775 1286 1408 3 -1222 1340 1447 770 3 -1898 1599 341 740 3 -568 1944 730 1288 3 -1855 848 585 1778 3 -1018 1429 218 7 3 -1065 1784 1168 665 3 -600 1605 1672 979 3 -912 165 164 1543 3 -1703 471 1362 696 3 -850 1941 558 474 3 -1701 683 618 525 3 -271 1590 1372 1303 3 -746 745 1702 945 3 -211 1841 382 1666 3 -1672 1775 979 1252 3 -1086 952 1683 1324 3 -1666 211 1841 1655 3 -1894 1618 329 630 3 -397 1702 745 396 3 -397 746 745 1702 3 -455 918 1618 329 3 -1678 1907 1381 1154 3 -449 781 1416 1885 3 -601 1089 1452 1515 3 -763 696 471 1703 3 -333 724 481 907 3 -1567 1145 1554 294 3 -903 356 794 175 3 -1743 1353 968 1543 3 -440 1330 1288 1045 3 -1676 337 1001 1304 3 -454 149 607 1705 3 -1896 1764 1307 694 3 -1278 1818 1509 1152 3 -1265 1578 1956 1946 3 -1017 929 1135 304 3 -1135 929 73 304 3 -1135 1870 995 606 3 -1404 1477 760 1538 3 -1843 477 1773 669 3 -19 1540 1092 1707 3 -482 993 1476 611 3 -466 1356 1954 1674 3 -1836 1271 665 1328 3 -15 185 1663 805 3 -1670 1552 1243 621 3 -166 1205 1299 1462 3 -477 1481 1773 669 3 -1585 840 1709 1682 3 -825 713 44 1201 3 -292 1091 691 1545 3 -1644 1491 1625 373 3 -1412 44 1201 825 3 -736 790 52 170 3 -1670 621 1243 569 3 -1371 878 1011 1817 3 -1551 1806 1007 289 3 -80 1188 1229 1376 3 -1381 1678 1681 1907 3 -1856 1411 878 1817 3 -415 1381 39 1103 3 -1653 970 464 1645 3 -608 1709 415 1685 3 -691 49 1593 1545 3 -1761 1034 894 1321 3 -1151 608 1922 1709 3 -458 1116 363 1061 3 -679 1545 49 691 3 -1151 39 608 1709 3 -1926 1413 1421 1405 3 -1612 1760 588 1499 3 -1709 1585 1681 1381 3 -732 1179 1716 1429 3 -1849 1460 482 1003 3 -1710 948 1170 1427 3 -1407 1710 1170 1427 3 -1580 381 1101 344 3 -1662 1710 1170 1407 3 -1662 811 1710 1407 3 -1603 1209 782 366 3 -694 1629 1307 1421 3 -366 1209 782 1261 3 -215 307 1842 1280 3 -1711 612 1177 1525 3 -1179 732 1716 1157 3 -1745 1235 1004 1254 3 -1478 1666 1745 1131 3 -1745 1666 335 1131 3 -1213 1270 1038 1737 3 -1943 532 1093 1712 3 -1373 754 545 1615 3 -532 1042 1712 846 3 -1136 915 510 1512 3 -1712 16 1093 683 3 -525 16 1712 683 3 -772 489 1855 693 3 -871 1194 1851 1867 3 -1409 1748 1500 1245 3 -1559 1407 1241 1233 3 -1793 1557 1675 1291 3 -294 1145 1443 139 3 -1541 1498 1725 777 3 -1843 477 1635 1773 3 -94 129 654 394 3 -1500 1748 1486 1245 3 -1255 1754 1217 406 3 -1413 1076 618 1605 3 -1735 848 585 1855 3 -1461 1722 986 1089 3 -1255 1834 18 1314 3 -1954 1674 575 1385 3 -1917 318 1098 386 3 -428 1600 879 1650 3 -1716 1232 596 1557 3 -1276 1044 898 1030 3 -941 1766 669 1132 3 -1214 311 695 1756 3 -1648 1716 1418 552 3 -1648 1157 1716 552 3 -1386 1949 1934 353 3 -1537 1157 1716 1648 3 -1232 1716 1169 1041 3 -1232 1557 1716 1041 3 -1716 1169 1429 1232 3 -1569 462 594 1014 3 -1766 1370 1110 669 3 -1766 1412 648 44 3 -941 1766 1132 1412 3 -669 1766 1481 1132 3 -818 964 1531 524 3 -33 497 819 1565 3 -570 1206 1531 372 3 -778 1531 360 372 3 -778 570 1531 372 3 -1160 744 1832 1080 3 -1610 1815 748 1027 3 -589 508 939 1058 3 -1228 1555 1165 198 3 -1720 1712 1700 1544 3 -1042 1712 1700 1720 3 -1712 1720 951 1544 3 -1712 1042 951 1720 3 -1446 1825 1595 571 3 -372 524 1726 97 3 -1640 1944 730 568 3 -1781 1050 693 1235 3 -260 775 717 136 3 -1723 617 479 1458 3 -1606 1260 1556 428 3 -428 1606 1109 1556 3 -428 1109 1650 1556 3 -879 428 1650 1556 3 -531 1289 1928 1031 3 -1458 1164 601 1523 3 -765 1721 1576 1047 3 -765 954 1721 1047 3 -1791 1081 656 1607 3 -1513 1787 592 354 3 -1529 394 94 654 3 -1922 1685 755 1682 3 -1902 744 1073 543 3 -710 1600 1218 1828 3 -1434 1423 644 1327 3 -1077 598 1158 426 3 -1179 189 155 218 3 -568 30 45 1640 3 -1851 1194 809 1765 3 -1748 1178 556 1245 3 -721 1 1316 212 3 -1765 472 1097 1851 3 -1847 1595 927 1825 3 -1500 1280 1274 624 3 -532 1231 1877 1093 3 -721 279 212 1935 3 -903 315 1499 356 3 -1034 1761 1061 1321 3 -903 1506 1586 794 3 -1568 1730 1855 1946 3 -1214 458 908 860 3 -1473 1064 704 1532 3 -1458 1293 1723 617 3 -471 913 1839 770 3 -510 56 1602 1839 3 -510 1362 1839 1602 3 -510 1362 471 1839 3 -479 1349 780 897 3 -269 283 628 911 3 -1441 1578 1956 1265 3 -572 740 1041 1191 3 -950 1382 532 1727 3 -226 1224 259 279 3 -808 24 798 1936 3 -1776 1788 644 1038 3 -1038 863 1788 644 3 -1569 462 1238 594 3 -1227 867 1788 1776 3 -1920 1892 737 1568 3 -762 334 1642 640 3 -60 1904 983 358 3 -240 877 1924 1166 3 -1214 458 1848 908 3 -1395 1692 1887 459 3 -849 734 1310 579 3 -1322 556 501 1897 3 -1659 551 414 368 3 -240 877 1166 273 3 -666 1260 1732 963 3 -1476 1953 1355 817 3 -1711 1736 1887 671 3 -1913 731 492 1193 3 -1178 1732 1154 671 3 -1732 858 666 633 3 -899 1732 963 633 3 -1732 858 633 1251 3 -548 858 1732 1251 3 -1732 666 963 633 3 -1260 899 963 672 3 -1433 1030 59 1957 3 -858 1260 1732 666 3 -654 1630 1792 414 3 -373 1483 1314 1210 3 -1395 750 1692 459 3 -1628 1921 1790 1933 3 -849 579 1310 275 3 -628 283 1082 911 3 -53 832 1470 1323 3 -1513 1757 1883 876 3 -1058 486 36 1654 3 -931 1374 774 643 3 -930 1936 798 1315 3 -1649 1109 1576 14 3 -216 1940 298 1459 3 -1467 1756 311 224 3 -65 1751 1787 1847 3 -1260 899 1732 963 3 -154 919 424 595 3 -1229 1074 839 851 3 -943 1737 867 1270 3 -943 1364 867 1737 3 -1916 768 1907 1678 3 -1747 1173 1262 1550 3 -488 1357 1876 789 3 -1645 636 1763 1796 3 -1769 318 1863 988 3 -1034 894 1888 1761 3 -1890 1796 850 401 3 -774 1201 44 713 3 -1755 247 1859 434 3 -1007 854 1201 1021 3 -522 217 245 261 3 -1847 1787 65 1595 3 -867 1105 1652 813 3 -105 595 154 250 3 -774 854 1201 1007 3 -774 854 44 1201 3 -482 1438 1252 979 3 -1153 921 1675 1110 3 -1176 811 1407 1512 3 -645 1826 1069 1889 3 -1439 1576 1187 1649 3 -546 1113 532 638 3 -1028 626 540 1714 3 -1742 1110 1675 1291 3 -1153 1110 1675 1742 3 -1742 1153 1110 786 3 -855 1882 1714 1028 3 -1323 832 1470 1865 3 -500 1842 1409 1743 3 -1409 968 947 1743 3 -1245 1409 1743 500 3 -550 1245 671 1743 3 -1743 1329 177 1543 3 -834 1186 1899 168 3 -1743 1353 1543 48 3 -28 1807 560 261 3 -1409 671 1743 947 3 -1409 671 1245 1743 3 -1743 947 1329 968 3 -871 1194 809 1851 3 -177 947 1329 1743 3 -1743 968 1329 1543 3 -568 1223 45 1276 3 -443 1426 731 1770 3 -1604 820 938 1794 3 -1419 443 1001 924 3 -395 1678 1463 427 3 -345 1635 1561 887 3 -565 1561 1350 345 3 -1495 507 812 1542 3 -1245 801 833 1486 3 -1697 30 1944 1640 3 -1799 405 1379 1945 3 -1771 382 233 1131 3 -569 1643 1243 1670 3 -1643 1746 1670 1742 3 -1643 1557 1746 1742 3 -181 889 700 1352 3 -1746 1041 1232 936 3 -1643 1746 1232 936 3 -1244 1746 1670 1552 3 -1180 1894 329 630 3 -1746 1244 1670 1291 3 -452 1875 71 446 3 -1746 1557 1291 1742 3 -1670 1746 1291 1742 3 -1853 37 563 1538 3 -1179 1429 596 1716 3 -1853 1027 672 750 3 -1860 1687 866 1546 3 -782 1860 350 1546 3 -1177 1300 924 1733 3 -715 1789 1401 1596 3 -436 1097 1671 1054 3 -1268 1603 1606 395 3 -395 1088 1260 428 3 -1253 1429 7 732 3 -395 1209 548 427 3 -864 1192 1394 1446 3 -1463 1209 395 427 3 -1322 1019 501 427 3 -290 1702 1893 661 3 -1831 84 1106 530 3 -1312 1826 645 1889 3 -290 1893 1397 661 3 -1841 197 1596 351 3 -1845 1367 1322 1630 3 -1933 1597 1698 1780 3 -1659 970 1750 930 3 -1581 1122 1157 1179 3 -901 472 17 1194 3 -1802 1622 1718 514 3 -804 1802 514 885 3 -902 217 298 1459 3 -1264 712 792 484 3 -1506 813 867 1227 3 -763 981 1145 1703 3 -1227 1788 1586 1776 3 -1227 1506 1586 1788 3 -1850 1163 526 67 3 -1167 1848 1081 814 3 -1187 1658 1498 777 3 -1776 867 1788 1038 3 -606 1428 995 1753 3 -1753 1149 1540 678 3 -14 964 1187 1649 3 -751 142 1799 1318 3 -1774 1350 1234 888 3 -882 14 886 1774 3 -1234 1774 886 1444 3 -1946 1956 1694 969 3 -1694 76 1956 1464 3 -94 1830 1529 1792 3 -723 1956 969 909 3 -1747 1701 1090 1332 3 -1694 909 1212 969 3 -1694 1464 1956 1946 3 -608 1685 1553 1642 3 -1685 49 1754 1642 3 -1642 1754 1553 516 3 -556 1897 1562 501 3 -64 1055 754 1769 3 -854 774 1254 643 3 -1544 1701 1700 1090 3 -1544 1712 1700 1701 3 -1544 525 1701 1090 3 -1544 525 1712 1701 3 -944 1504 1134 803 3 -1700 1712 1216 1701 3 -1701 1747 1262 1550 3 -1294 1912 1373 802 3 -1722 1747 1262 1701 3 -275 311 1756 224 3 -275 1756 555 579 3 -1424 1828 710 1757 3 -907 481 173 791 3 -1587 1929 47 1841 3 -118 355 966 777 3 -1912 545 802 587 3 -1499 1820 1612 447 3 -334 1593 1642 516 3 -1370 1766 1366 1930 3 -1614 1757 1698 23 3 -484 712 474 1264 3 -1513 1757 876 1713 3 -1513 1070 1614 1757 3 -1601 184 674 1318 3 -795 39 415 608 3 -571 1170 1427 1660 3 -1949 612 991 1177 3 -1949 353 1259 912 3 -377 1233 881 1814 3 -717 1542 1623 815 3 -188 871 1122 25 3 -1786 655 23 1594 3 -1542 717 1623 1442 3 -1905 1396 1316 1879 3 -1817 1616 717 1542 3 -1290 1364 357 1128 3 -787 738 938 1057 3 -1668 1290 1760 357 3 -1668 1290 1389 1760 3 -1557 1898 341 1041 3 -846 1216 1712 1943 3 -1103 415 795 39 3 -1255 1314 18 573 3 -1627 1091 1545 679 3 -501 1019 1393 427 3 -523 553 1781 1893 3 -1390 380 114 399 3 -551 930 1659 1750 3 -866 1358 1269 1763 3 -1878 414 1659 1750 3 -633 551 666 667 3 -827 195 1030 1957 3 -850 1358 866 1763 3 -559 1360 222 55 3 -1026 1637 1751 1846 3 -154 1211 595 105 3 -1930 1226 784 989 3 -1856 1817 1371 875 3 -1529 1830 247 1859 3 -623 772 1589 693 3 -1529 1859 1845 1792 3 -1294 1741 1838 1667 3 -1031 1210 1622 668 3 -1516 1851 809 1054 3 -238 975 1572 1274 3 -243 363 1167 1451 3 -1757 1078 1828 1070 3 -1132 995 1753 1955 3 -1587 1596 1471 1841 3 -1443 403 821 1472 3 -1831 599 1106 84 3 -1185 969 1660 1778 3 -1453 1765 809 1194 3 -1263 449 319 1885 3 -1263 1881 781 1885 3 -905 1542 538 1768 3 -1422 1226 784 653 3 -1726 524 360 1693 3 -783 1542 507 1019 3 -810 558 1768 905 3 -1028 544 1148 1832 3 -1688 1768 602 1495 3 -1688 1575 602 1768 3 -933 1924 1340 1634 3 -1575 1768 1688 919 3 -1211 1768 1575 919 3 -1211 810 1768 919 3 -1768 1575 474 1211 3 -558 1768 474 1211 3 -558 810 1768 1211 3 -693 737 1781 687 3 -1295 1617 935 613 3 -1768 1068 793 602 3 -1495 1068 1768 602 3 -1823 1773 1707 345 3 -494 1522 1185 1143 3 -1736 1501 1770 443 3 -934 700 889 605 3 -1260 1770 1598 879 3 -345 1837 1181 1773 3 -1047 1576 1181 345 3 -1047 345 1181 1779 3 -1721 1047 1823 345 3 -565 1635 1561 345 3 -1837 1635 345 887 3 -1713 1757 876 338 3 -565 1350 1234 345 3 -669 1773 1132 1481 3 -480 1013 418 1305 3 -1924 877 1791 1848 3 -1181 887 345 1576 3 -1418 536 1191 1010 3 -1916 1678 1463 395 3 -1914 1379 513 142 3 -1117 219 1319 936 3 -1412 1201 1661 625 3 -915 789 1126 1279 3 -167 531 578 593 3 -345 1561 1350 887 3 -881 1544 1933 1665 3 -1828 768 1916 1088 3 -1720 1522 951 1814 3 -763 1145 547 1703 3 -1017 1132 1950 1135 3 -1010 1216 1775 1599 3 -1010 1216 1672 1775 3 -1262 1599 1550 1449 3 -2 1358 850 1895 3 -1219 486 842 1654 3 -1135 1237 156 1950 3 -304 1237 1950 222 3 -1775 1438 1636 979 3 -1515 1438 1636 1775 3 -1775 1438 979 1252 3 -1547 1252 1775 816 3 -1547 1438 1515 1775 3 -763 547 139 1906 3 -547 1906 1703 1472 3 -1265 76 1464 1956 3 -1672 1701 1775 1216 3 -1655 1596 1471 1789 3 -1447 1340 990 849 3 -476 1858 635 248 3 -751 1799 674 1318 3 -635 1621 686 1858 3 -1667 53 1669 1611 3 -998 330 521 150 3 -1224 822 1785 604 3 -852 1867 1537 1157 3 -898 1030 982 819 3 -1159 1821 1072 778 3 -1710 1213 1517 1777 3 -1284 763 1906 257 3 -1068 1664 1484 1921 3 -1284 1906 1919 257 3 -515 1631 853 1376 3 -437 1395 828 1887 3 -832 1669 1470 1248 3 -1212 1185 1778 969 3 -532 1042 1298 1712 3 -606 736 1428 1779 3 -1762 1895 850 1309 3 -1268 1078 1813 1916 3 -1181 1837 345 887 3 -1779 345 1773 1823 3 -1779 1248 1753 1773 3 -1739 1534 931 256 3 -1301 1383 1779 736 3 -1301 1383 1047 1779 3 -1102 4 1118 1569 3 -1481 383 1773 1132 3 -463 1708 1610 1815 3 -705 1475 1782 1684 3 -705 1475 1344 1782 3 -713 774 1806 306 3 -925 515 853 642 3 -1790 1698 1786 1933 3 -97 847 1349 527 3 -901 1336 17 472 3 -1759 1505 884 438 3 -1475 1049 1344 1782 3 -1785 822 301 1065 3 -226 822 301 1785 3 -1786 1757 1268 1594 3 -23 1757 1786 1594 3 -101 66 1593 100 3 -971 1231 1877 532 3 -814 1791 1573 276 3 -964 1039 932 1854 3 -604 992 1626 1224 3 -814 656 1573 1791 3 -953 984 592 1787 3 -1025 953 1380 1787 3 -1787 1170 1380 1595 3 -1869 1516 809 1471 3 -1884 19 1670 786 3 -786 829 1000 1326 3 -1808 1806 931 306 3 -1092 19 1884 786 3 -1094 191 917 543 3 -458 1451 1166 1848 3 -1787 953 1513 592 3 -1380 953 1513 1787 3 -1007 931 201 1806 3 -1508 1208 1793 1336 3 -64 1055 1493 754 3 -1111 1413 1414 468 3 -544 1800 1148 1832 3 -215 307 297 1842 3 -1414 1413 1926 468 3 -1805 1444 1549 1721 3 -582 1522 1720 1488 3 -1789 1655 623 1503 3 -1471 1655 1789 1503 3 -881 1814 1780 1544 3 -1860 1759 703 1505 3 -1239 499 1835 1809 3 -1786 1078 1790 1268 3 -582 1522 951 1720 3 -633 858 551 1251 3 -1187 964 932 1854 3 -930 1199 1750 551 3 -81 1166 274 273 3 -1557 341 1716 1041 3 -566 1380 943 1923 3 -1864 1655 1666 335 3 -943 1364 1737 1923 3 -1350 1431 986 338 3 -338 1424 1492 1350 3 -1561 1424 338 1350 3 -1561 1424 1713 338 3 -338 1492 1594 986 3 -1747 338 1594 986 3 -1757 1492 1594 338 3 -23 338 1594 1747 3 -23 1757 1594 338 3 -1336 901 17 1793 3 -1625 1794 1579 1445 3 -1625 1377 1579 1794 3 -1794 1172 1579 1445 3 -820 1172 1579 1794 3 -992 726 482 1905 3 -1922 608 1400 1685 3 -1922 1682 1398 1681 3 -1922 755 1400 1239 3 -273 877 1167 242 3 -562 1588 567 1171 3 -30 1944 568 1275 3 -1166 877 1924 1848 3 -1034 1761 1888 1061 3 -1795 1170 1380 1513 3 -1070 1170 1795 1513 3 -1583 1513 1795 1380 3 -1583 1513 1070 1795 3 -992 482 816 1905 3 -726 1879 482 1905 3 -1396 498 1 1879 3 -989 1431 1173 1040 3 -1796 850 473 636 3 -401 850 473 1796 3 -1813 1608 1174 603 3 -1026 1846 1751 1735 3 -956 489 772 1347 3 -1388 1055 1913 492 3 -1608 1813 1734 1907 3 -1569 987 462 1363 3 -1122 596 1179 1067 3 -1324 580 196 597 3 -43 1800 1497 1247 3 -1168 689 262 1723 3 -1843 1431 1930 1370 3 -1049 1782 1767 369 3 -1375 893 1800 629 3 -1375 893 544 1800 3 -735 173 1242 1758 3 -1483 576 1797 1802 3 -458 1888 205 1061 3 -1529 1859 247 1679 3 -163 1527 162 529 3 -1148 893 629 1800 3 -20 1797 1066 303 3 -1801 1688 602 1289 3 -785 1688 1801 1289 3 -1207 1453 1765 1868 3 -557 1483 514 1654 3 -881 1474 377 1544 3 -1299 1797 576 1802 3 -1736 443 1770 1803 3 -1732 1803 1770 1088 3 -1732 1736 1770 1803 3 -982 819 1639 952 3 -1066 1797 208 303 3 -1066 1802 208 1797 3 -1299 1802 576 1462 3 -1299 1205 1802 1462 3 -1797 1802 208 557 3 -303 557 208 236 3 -1156 645 1416 781 3 -653 1930 784 448 3 -1834 1804 1704 1377 3 -1384 1536 1704 1804 3 -1483 576 1802 1622 3 -1942 346 324 631 3 -277 1633 11 1342 3 -1804 1210 1377 1625 3 -1536 1377 1704 1804 3 -1057 1176 811 603 3 -840 1682 1585 406 3 -1057 811 1502 1835 3 -1835 499 1517 1602 3 -1370 1843 1431 1570 3 -1898 1557 1291 1746 3 -968 947 1910 1409 3 -1805 1552 886 888 3 -1234 1805 886 888 3 -1178 1251 1845 1322 3 -1837 1470 1248 1635 3 -1809 908 1034 1925 3 -1367 1845 1322 1748 3 -414 1845 1251 1630 3 -1792 1845 414 1630 3 -391 1476 1355 817 3 -1178 1845 1748 1322 3 -1942 631 1430 1093 3 -1838 639 1611 1470 3 -718 830 536 184 3 -1316 609 1905 352 3 -1214 272 1222 1924 3 -333 1885 343 724 3 -458 860 274 205 3 -1863 491 802 1263 3 -1845 1251 633 414 3 -1317 926 678 559 3 -850 1358 2 1941 3 -1880 214 170 34 3 -1316 1396 1 1879 3 -1312 408 1889 892 3 -1212 1778 1855 969 3 -1338 755 1398 457 3 -1389 701 1833 1009 3 -1445 1174 603 1813 3 -1476 993 1482 611 3 -1009 701 1833 1521 3 -1521 701 1833 1025 3 -1389 701 645 1833 3 -1009 1156 1833 1389 3 -1218 545 1583 1504 3 -540 615 999 517 3 -1688 1811 424 595 3 -781 1833 645 1025 3 -898 1030 469 982 3 -919 1688 424 595 3 -919 1861 424 1688 3 -1608 1734 483 1907 3 -1937 1564 1604 505 3 -1867 1851 1097 472 3 -880 1313 1818 806 3 -880 681 707 1313 3 -1172 1174 603 1445 3 -1268 1813 1790 1463 3 -1901 1118 484 1405 3 -472 534 1097 1867 3 -1394 1192 1886 647 3 -1394 1886 577 647 3 -1013 1034 1809 1450 3 -1123 466 955 84 3 -1453 862 1131 564 3 -1599 1648 341 1010 3 -1886 1192 1175 837 3 -534 472 1336 1508 3 -377 1544 951 1814 3 -632 745 927 1954 3 -591 1366 989 1370 3 -347 1394 1554 398 3 -1844 1301 521 1904 3 -275 1756 1447 555 3 -1212 1892 1855 489 3 -1537 1122 901 596 3 -1682 755 1816 1685 3 -1086 819 952 1124 3 -1374 1534 931 1739 3 -823 116 737 706 3 -1842 968 1743 1353 3 -1357 471 981 933 3 -391 1158 1476 817 3 -1800 192 1497 1818 3 -1148 1313 1818 629 3 -1853 1072 836 1159 3 -995 1135 606 1955 3 -1593 691 1545 141 3 -389 1285 1535 1344 3 -1163 707 1850 526 3 -880 681 1313 806 3 -880 1313 707 1818 3 -526 707 1818 880 3 -526 707 1497 1818 3 -691 1091 939 679 3 -1908 775 717 280 3 -707 1818 629 1497 3 -707 1313 629 1818 3 -10 1489 1646 281 3 -1477 1531 1072 1821 3 -1888 480 418 295 3 -1850 508 1163 67 3 -1849 374 392 1460 3 -663 997 1473 1532 3 -860 1888 244 205 3 -1502 1060 1057 457 3 -368 414 1529 684 3 -508 707 1850 1163 3 -1405 987 1421 694 3 -1475 340 1344 1049 3 -1446 647 1825 571 3 -1828 1916 395 1088 3 -1916 1907 1813 1678 3 -567 560 1823 19 3 -567 560 954 1823 3 -860 418 244 1888 3 -1268 1916 395 1828 3 -395 1916 1678 1088 3 -1734 1078 1828 1916 3 -1734 1916 1828 768 3 -1442 280 717 1623 3 -563 1277 750 459 3 -25 1689 1122 1120 3 -568 1944 1288 1275 3 -448 1766 1366 44 3 -1781 865 687 1397 3 -553 865 890 1781 3 -375 49 1685 1642 3 -327 1730 845 906 3 -1672 1605 600 618 3 -877 814 1167 242 3 -1729 1505 1283 703 3 -1493 1677 1440 1615 3 -51 1249 748 1913 3 -894 1450 1034 416 3 -1416 342 1826 645 3 -759 1416 1826 1069 3 -343 1416 342 759 3 -1827 916 625 825 3 -1915 1827 625 825 3 -1829 541 1131 1745 3 -266 1827 1144 225 3 -266 1360 1144 1827 3 -1615 754 545 1009 3 -1827 1256 825 225 3 -266 1256 1827 225 3 -1360 1256 916 1827 3 -1212 1730 1855 1892 3 -660 1303 1274 801 3 -1268 1757 1828 428 3 -1268 1757 1078 1828 3 -1828 1088 395 428 3 -1268 1828 395 428 3 -1008 1829 1478 1745 3 -1471 1054 809 382 3 -1869 1471 809 1929 3 -37 1815 1853 1027 3 -1516 1587 1471 1869 3 -1446 1385 1825 647 3 -1829 541 1008 648 3 -581 541 1829 648 3 -1220 1408 270 237 3 -1838 1470 1611 1669 3 -581 541 1131 1829 3 -667 1133 680 419 3 -1653 1645 1750 970 3 -368 1936 367 798 3 -99 480 249 762 3 -99 98 249 480 3 -1619 582 1042 1720 3 -1105 403 1472 425 3 -822 198 1343 1065 3 -1611 1713 639 1424 3 -1064 1545 254 512 3 -150 767 1749 998 3 -1261 1283 1750 350 3 -1840 1107 1261 1860 3 -1645 5 1283 1468 3 -928 1708 1947 1190 3 -94 129 1792 654 3 -1263 802 781 1881 3 -1218 545 1373 1912 3 -1740 550 912 1743 3 -948 1512 1511 1427 3 -1511 1512 948 1362 3 -1856 1817 875 260 3 -849 1906 85 734 3 -1415 1140 1410 123 3 -1573 656 806 788 3 -1373 545 1368 1615 3 -313 227 1836 1271 3 -540 517 999 1073 3 -1082 711 628 573 3 -1833 1521 1025 587 3 -781 1833 1025 587 3 -1876 1357 502 293 3 -1276 918 1618 455 3 -1255 406 18 1834 3 -1562 1834 1625 18 3 -1562 406 1834 18 3 -1585 1834 1625 1562 3 -1585 406 1834 1562 3 -1834 1704 1398 1579 3 -1681 1834 1398 1579 3 -1625 1377 1834 1579 3 -937 610 1626 1552 3 -603 1681 1835 1398 3 -1835 499 56 1809 3 -1502 1835 56 1809 3 -1835 1502 1057 457 3 -1398 1835 1057 457 3 -603 1835 1057 1398 3 -1265 1946 575 1385 3 -1134 1009 545 1504 3 -273 276 877 242 3 -1382 1619 532 1727 3 -1218 545 1368 1373 3 -1208 378 1550 1173 3 -545 1134 1368 1615 3 -193 744 1160 1080 3 -513 103 1914 142 3 -532 1619 846 1727 3 -1245 1500 801 1486 3 -316 607 1337 1434 3 -1761 205 1061 258 3 -983 677 1036 1900 3 -928 1039 1708 1610 3 -382 960 1929 251 3 -841 1390 757 870 3 -383 1189 653 1865 3 -1274 975 651 1519 3 -531 999 1928 1289 3 -1428 995 1248 1870 3 -677 1741 1181 521 3 -480 1013 1305 375 3 -537 946 795 1423 3 -1626 1784 1243 1552 3 -1178 1845 1346 1748 3 -1759 817 703 438 3 -382 251 1929 211 3 -700 180 574 753 3 -1450 1239 457 1809 3 -1013 1809 1239 1450 3 -1759 703 1505 438 3 -366 1261 1840 1107 3 -366 1261 782 1840 3 -1211 810 595 1948 3 -887 1650 1424 1109 3 -805 694 1857 807 3 -963 419 667 367 3 -732 1029 552 1267 3 -685 741 648 581 3 -918 1275 1618 325 3 -1493 74 1440 844 3 -783 812 1542 1623 3 -783 812 507 1542 3 -1852 1105 425 1062 3 -1019 1542 507 538 3 -1019 905 1542 538 3 -1542 1046 905 1019 3 -815 1046 1542 1019 3 -854 1846 1637 1050 3 -854 1257 1846 1050 3 -1026 1050 1846 1735 3 -1026 1050 1637 1846 3 -953 1713 1912 1513 3 -945 1026 1847 927 3 -1847 1735 1026 1751 3 -1855 1735 1026 1847 3 -1244 1291 1884 1670 3 -1291 1742 1110 1884 3 -1660 1847 571 1170 3 -1884 1707 1570 1244 3 -1847 1595 1825 571 3 -1698 1078 1174 1790 3 -1170 1595 1847 571 3 -1170 1595 1787 1847 3 -325 326 440 977 3 -774 1745 1131 541 3 -50 940 958 1850 3 -1850 112 508 67 3 -113 112 1850 67 3 -1850 57 508 112 3 -113 57 1850 112 3 -275 1447 1756 311 3 -1058 1850 707 36 3 -1058 940 1850 36 3 -1850 707 36 1497 3 -958 1850 36 1497 3 -1850 958 158 1497 3 -113 1850 158 526 3 -50 1850 158 113 3 -50 958 158 1850 3 -551 667 633 684 3 -1783 1739 931 256 3 -307 238 1939 1079 3 -1475 1812 340 1899 3 -1785 1626 923 1117 3 -1526 358 1036 983 3 -85 1510 1533 1227 3 -60 1844 521 1904 3 -675 1567 398 1554 3 -458 274 1451 1116 3 -1248 533 1904 1527 3 -1650 1658 1741 1584 3 -843 118 677 1485 3 -1102 4 1569 594 3 -1838 1611 1656 1294 3 -1905 1396 1879 482 3 -385 1347 370 1767 3 -1574 1580 1101 344 3 -613 84 530 1106 3 -709 708 361 424 3 -1422 1333 1323 635 3 -372 524 360 1726 3 -1487 379 1211 1141 3 -1529 1845 1859 1346 3 -1948 810 595 104 3 -1487 1141 1211 105 3 -1656 1741 42 1650 3 -887 1838 1656 1741 3 -1529 654 1792 414 3 -1907 1154 1469 1381 3 -1692 1913 492 456 3 -1763 1505 5 1309 3 -169 1869 47 1587 3 -803 863 1733 586 3 -169 187 1869 871 3 -169 1869 1587 733 3 -1258 584 1300 1733 3 -1297 1777 1151 483 3 -939 508 137 1761 3 -1588 1383 567 1171 3 -1078 1070 1174 1734 3 -874 1458 1523 689 3 -596 1179 218 1429 3 -981 1203 1567 1357 3 -930 1404 1936 1315 3 -209 431 796 788 3 -672 1477 1610 1853 3 -1404 760 1936 808 3 -1659 1653 1750 970 3 -333 343 481 724 3 -910 668 1797 1571 3 -585 1824 876 1883 3 -1187 1649 1854 1658 3 -1187 1649 964 1854 3 -1470 53 1611 1669 3 -259 1785 1117 1224 3 -440 1045 1288 1037 3 -1956 909 1694 969 3 -181 180 574 700 3 -914 452 1782 1684 3 -914 1143 452 1684 3 -862 41 299 564 3 -1007 774 643 931 3 -823 116 1892 737 3 -1456 657 925 991 3 -1456 657 182 925 3 -1935 279 212 263 3 -1138 1169 1935 1253 3 -1857 1307 1037 1764 3 -805 1307 1306 1857 3 -991 657 925 537 3 -1701 525 1712 683 3 -1795 554 1213 764 3 -1301 1428 1181 1904 3 -1456 181 182 657 3 -677 491 1036 1900 3 -1613 1288 15 1857 3 -1857 1764 1037 1045 3 -1330 1764 1857 1045 3 -805 1629 1307 694 3 -409 27 1146 1311 3 -1829 1131 1868 1478 3 -588 1677 1612 1820 3 -823 706 737 693 3 -1346 1859 1679 947 3 -950 871 1516 1851 3 -1529 1346 1679 684 3 -338 1747 876 1173 3 -823 116 489 1892 3 -693 1892 1855 523 3 -1259 181 68 779 3 -1529 1830 1859 1792 3 -1569 1162 1016 1014 3 -612 1711 1177 1949 3 -31 234 997 628 3 -823 1892 489 693 3 -1932 441 453 336 3 -782 1261 1860 1840 3 -782 1261 350 1860 3 -1840 1860 782 1546 3 -1840 1687 1860 1546 3 -1785 1271 6 923 3 -1769 1863 754 988 3 -925 349 1733 176 3 -1795 1737 1923 1270 3 -876 1747 1332 1173 3 -991 1733 1177 853 3 -338 1747 23 876 3 -1681 1907 483 1381 3 -259 1224 1117 279 3 -604 611 993 992 3 -1102 1238 1405 1926 3 -566 1923 943 1270 3 -554 1504 1583 1923 3 -1923 701 1380 943 3 -1923 1504 1583 1521 3 -1795 1583 1380 1923 3 -1364 701 1504 1923 3 -1364 1923 1504 1737 3 -1923 1583 1380 1521 3 -1818 192 1509 1152 3 -1921 1790 1172 1445 3 -1469 800 483 39 3 -950 871 1851 1867 3 -1709 483 1151 39 3 -318 386 1917 619 3 -1131 1868 1453 581 3 -1131 1829 1868 581 3 -1117 279 1224 1319 3 -1752 56 1809 908 3 -1829 1131 1478 1745 3 -317 491 619 318 3 -1917 491 1584 42 3 -1309 1505 5 1331 3 -1801 1896 1184 980 3 -887 639 1838 1635 3 -1090 1747 1722 1701 3 -1011 473 1817 1046 3 -151 1383 1301 1198 3 -1869 809 1516 871 3 -151 1198 1844 171 3 -491 1741 1584 42 3 -491 1294 1741 42 3 -1181 1741 1838 887 3 -1181 1439 1741 887 3 -795 753 1423 1337 3 -1181 1439 521 1741 3 -761 901 596 485 3 -103 404 1914 142 3 -1914 1003 513 1379 3 -1839 1602 1362 1752 3 -1838 1470 1837 1635 3 -1247 1375 1497 36 3 -1335 1926 451 1872 3 -1034 857 1321 363 3 -1761 508 258 1321 3 -652 371 1699 402 3 -1622 576 22 1031 3 -1107 1089 1490 1164 3 -325 918 329 1618 3 -652 402 703 598 3 -1475 1812 546 1308 3 -1817 815 1046 1542 3 -1211 919 411 154 3 -1812 1535 1344 389 3 -390 1535 1812 389 3 -398 1394 577 1441 3 -1231 390 1535 1812 3 -1043 1807 560 1171 3 -1798 1527 358 163 3 -705 1475 1308 1344 3 -1128 1105 813 1852 3 -1878 393 1011 1796 3 -464 393 1878 1796 3 -1878 1796 1011 636 3 -1878 1645 464 1796 3 -422 1601 749 674 3 -1611 887 1424 639 3 -368 394 414 1878 3 -81 240 272 1924 3 -81 240 1924 1166 3 -1878 1645 1796 636 3 -1750 1645 1878 636 3 -151 170 34 1383 3 -954 1171 1383 1880 3 -1880 214 298 1043 3 -1171 214 1880 1043 3 -770 1214 908 695 3 -1215 1383 1880 954 3 -1212 1694 1730 489 3 -954 1171 1880 1043 3 -639 887 1424 1561 3 -669 1707 565 1570 3 -53 1294 1560 1881 3 -491 1881 1263 1560 3 -491 802 1263 1881 3 -760 419 367 808 3 -1848 877 1791 814 3 -545 1009 802 587 3 -724 1881 1069 53 3 -724 781 1069 1881 3 -1070 1608 1174 1734 3 -505 1764 1037 1937 3 -1410 123 517 1680 3 -982 1706 1810 1030 3 -1769 1863 490 754 3 -1211 919 1363 411 3 -317 491 318 1863 3 -665 277 1436 1342 3 -311 244 860 1467 3 -240 276 877 273 3 -66 133 504 691 3 -761 596 1122 1067 3 -1149 606 156 1955 3 -516 54 512 704 3 -971 733 834 1899 3 -603 1813 1608 1681 3 -1410 1680 1882 1119 3 -229 286 685 1871 3 -125 1410 1882 1119 3 -1545 1627 49 512 3 -669 1884 1707 1570 3 -679 1627 49 1545 3 -1884 1570 1370 1291 3 -669 1570 1370 1884 3 -902 298 1043 1940 3 -639 1226 784 1422 3 -1322 1897 783 478 3 -624 1367 1897 1500 3 -1322 1748 556 1897 3 -1486 1519 1562 1897 3 -1 726 1012 721 3 -881 1544 1780 1933 3 -1848 913 770 1839 3 -1545 1091 691 679 3 -551 666 1936 930 3 -1258 121 1300 584 3 -1886 1192 1472 1175 3 -416 49 504 679 3 -1483 1654 1314 1210 3 -679 691 49 504 3 -883 1247 958 143 3 -373 1196 1314 1483 3 -1069 1333 1826 1095 3 -1889 65 690 984 3 -1333 1889 690 984 3 -690 892 1889 408 3 -690 892 65 1889 3 -151 170 1198 52 3 -1830 1755 247 1859 3 -1416 1826 1069 645 3 -1294 1912 802 587 3 -1912 953 1583 587 3 -534 1867 472 1537 3 -744 35 1073 543 3 -1817 905 473 1616 3 -878 815 1817 1411 3 -710 1218 1373 1912 3 -818 509 14 479 3 -523 737 1892 1568 3 -1214 1166 458 860 3 -1904 1527 983 358 3 -1570 1291 1208 1040 3 -1626 937 1746 1041 3 -716 1689 1207 1453 3 -716 761 1207 1689 3 -90 1183 476 1200 3 -153 720 1146 732 3 -562 1149 567 1588 3 -1336 534 1508 1208 3 -411 919 1861 154 3 -850 1358 1763 1309 3 -1955 1132 1950 559 3 -884 1759 1269 1309 3 -494 1778 1855 1212 3 -1033 1185 1559 1522 3 -1500 624 1519 1897 3 -1486 1500 1519 1897 3 -1336 534 1097 472 3 -684 680 95 368 3 -1925 695 1809 908 3 -1370 1431 989 1040 3 -401 420 400 473 3 -1407 1512 1710 1427 3 -1589 494 1855 772 3 -517 1882 1680 1073 3 -699 539 1267 1146 3 -517 1073 1680 348 3 -123 517 1680 348 3 -329 455 1086 1618 3 -1022 1807 261 1043 3 -1907 768 1154 1678 3 -1108 1911 1866 1941 3 -344 506 982 469 3 -1119 1902 1548 433 3 -1119 744 1902 433 3 -1902 1882 1028 1073 3 -1902 544 1028 1832 3 -744 544 1902 1832 3 -1413 1102 1111 1901 3 -1119 744 1073 1902 3 -1607 1839 56 510 3 -1028 543 1902 1073 3 -1901 484 1413 1405 3 -755 49 1013 416 3 -1902 543 544 744 3 -1028 543 544 1902 3 -588 903 973 1820 3 -534 1537 1508 1648 3 -1820 1499 588 903 3 -1208 534 1508 1599 3 -1248 1527 1904 163 3 -1552 888 1805 1244 3 -1837 1248 1904 1181 3 -1904 1838 1181 677 3 -115 841 1390 957 3 -1904 533 1838 677 3 -1692 731 492 1913 3 -1516 1054 809 1471 3 -815 878 478 1411 3 -545 587 1912 1583 3 -1404 1315 930 1821 3 -1798 1904 1527 163 3 -974 1420 353 165 3 -965 1652 1906 1227 3 -1906 696 965 849 3 -47 197 1841 211 3 -211 1841 1655 351 3 -385 489 1347 117 3 -98 295 504 133 3 -1013 418 1925 1888 3 -1703 1472 1906 965 3 -257 1906 1919 85 3 -860 1925 418 1888 3 -1925 695 860 1467 3 -46 627 1149 89 3 -592 639 876 784 3 -1111 484 799 1413 3 -1346 1910 947 1409 3 -1598 1193 1913 748 3 -876 1757 23 338 3 -1748 1500 1859 1910 3 -1346 1748 1910 1409 3 -1346 1748 1859 1910 3 -546 1475 1113 638 3 -295 1197 1888 504 3 -545 587 1583 1521 3 -1912 953 1513 1583 3 -710 1912 1513 1583 3 -1294 1656 1912 1611 3 -1294 1656 1373 1912 3 -1656 1424 1912 1611 3 -1656 1424 1373 1912 3 -1713 1912 710 1424 3 -1713 1611 1912 1424 3 -1713 1912 1513 710 3 -1946 959 1825 571 3 -1436 897 479 1723 3 -1692 1738 1913 456 3 -1577 1692 492 456 3 -1837 1635 1773 345 3 -1828 1218 1734 768 3 -1888 1197 296 1761 3 -1382 1516 638 1401 3 -1587 1516 1401 733 3 -168 1401 1186 1899 3 -168 197 1401 1587 3 -168 197 1186 1401 3 -1401 1516 638 733 3 -1899 1401 638 733 3 -1665 1921 1933 881 3 -1789 1382 1684 1401 3 -168 1401 1899 733 3 -168 1587 1401 733 3 -1904 533 1837 1838 3 -17 921 1207 1918 3 -436 1918 1054 1478 3 -436 1097 1054 1918 3 -1821 1315 930 1695 3 -1507 421 1945 1130 3 -1957 962 59 1875 3 -1385 1674 1265 82 3 -1888 1013 416 1034 3 -603 1297 1835 1681 3 -1835 1297 1922 1681 3 -1111 1413 799 1414 3 -1202 1665 1921 1484 3 -1297 1922 1681 483 3 -1922 483 1151 1709 3 -1297 483 1151 1922 3 -896 1922 1297 1151 3 -896 1400 1922 1151 3 -1922 1400 896 1239 3 -1297 1922 896 1239 3 -1835 1922 457 1398 3 -1835 1681 1922 1398 3 -1835 1297 1239 1922 3 -705 1143 1298 1113 3 -1305 1013 418 1467 3 -1761 1888 1061 205 3 -43 917 1247 190 3 -1508 1557 1898 341 3 -1924 1222 1214 770 3 -1028 893 1148 544 3 -448 1637 673 1021 3 -1071 1457 1646 812 3 -295 1197 504 133 3 -504 480 1888 295 3 -504 480 1013 1888 3 -1888 418 244 295 3 -1187 1498 1541 777 3 -1085 1751 1637 784 3 -418 860 244 1467 3 -627 559 1149 89 3 -1305 1013 1467 1359 3 -1457 1071 1542 812 3 -1901 4 1264 1118 3 -892 745 955 1123 3 +5693 +87 86 28 311 1 +888 538 837 1028 1 +322 731 352 147 1 +240 77 749 272 1 +642 217 512 255 1 +693 1009 861 677 1 +908 100 346 54 1 +810 8 154 799 1 +726 1117 688 440 1 +563 604 501 1143 1 +68 181 471 164 1 +581 856 703 416 1 +113 112 1092 67 1 +846 949 614 780 1 +559 752 663 364 1 +64 119 328 74 1 +51 523 329 120 1 +1001 846 578 536 1 +396 366 166 167 1 +898 395 983 468 1 +27 623 372 124 1 +750 213 295 293 1 +102 278 530 126 1 +303 545 558 1066 1 +816 513 201 1055 1 +94 254 533 129 1 +500 419 978 936 1 +345 541 1118 669 1 +99 800 959 392 1 +637 964 1020 845 1 +411 587 332 316 1 +719 1087 1110 995 1 +999 1086 588 358 1 +396 332 988 1058 1 +477 602 444 469 1 +832 311 19 1123 1 +467 766 1039 380 1 +622 843 212 560 1 +226 1 278 875 1 +859 879 819 413 1 +28 87 349 825 1 +74 174 758 371 1 +620 464 380 1005 1 +504 369 634 996 1 +427 691 1053 971 1 +943 993 585 1016 1 +648 217 642 255 1 +101 363 210 54 1 +789 966 702 610 1 +167 185 432 186 1 +304 584 307 242 1 +951 768 398 439 1 +113 1092 561 67 1 +102 1 319 278 1 +66 539 1061 346 1 +963 1119 435 483 1 +329 51 120 907 1 +491 637 904 1051 1 +372 27 124 367 1 +555 648 642 497 1 +74 758 162 315 1 +790 1110 1087 358 1 +677 537 827 861 1 +113 1092 585 561 1 +405 403 813 332 1 +853 339 708 500 1 +688 1117 726 56 1 +602 414 726 469 1 +567 1080 864 1131 1 +237 264 987 236 1 +979 653 540 511 1 +1049 854 579 637 1 +375 537 223 751 1 +110 40 384 285 1 +783 803 22 665 1 +978 915 489 738 1 +618 11 227 273 1 +448 700 573 586 1 +388 43 158 192 1 +969 428 1145 953 1 +950 881 447 552 1 +1111 802 596 798 1 +701 732 964 886 1 +590 489 1036 704 1 +278 904 279 198 1 +960 213 146 333 1 +31 234 873 264 1 +284 1144 82 135 1 +33 683 317 586 1 +938 88 578 417 1 +349 255 214 642 1 +558 659 922 767 1 +726 1148 602 688 1 +605 462 576 463 1 +891 976 919 446 1 +772 538 354 890 1 +1133 945 1008 1020 1 +975 714 465 439 1 +138 980 96 952 1 +281 1001 535 578 1 +430 851 1090 946 1 +962 893 736 410 1 +383 16 564 332 1 +498 490 449 960 1 +560 875 843 896 1 +978 704 738 489 1 +1029 1069 324 601 1 +1022 1109 856 1098 1 +712 479 385 633 1 +614 844 418 770 1 +337 1023 830 941 1 +107 26 664 146 1 +196 125 587 193 1 +471 907 164 503 1 +369 634 754 184 1 +786 289 252 136 1 +1032 1034 906 738 1 +801 25 525 189 1 +290 891 291 205 1 +1042 760 674 877 1 +382 367 1039 766 1 +759 502 876 612 1 +889 484 922 745 1 +1099 615 992 879 1 +1036 704 1073 590 1 +907 918 374 471 1 +46 312 156 89 1 +779 534 865 855 1 +780 792 434 712 1 +168 197 624 400 1 +667 918 421 389 1 +868 482 1034 1006 1 +271 437 492 40 1 +531 325 600 990 1 +1064 441 260 541 1 +326 172 222 73 1 +260 441 230 541 1 +831 799 476 675 1 +122 27 372 576 1 +649 319 347 875 1 +384 111 323 492 1 +155 358 218 588 1 +349 255 512 28 1 +231 771 593 626 1 +1123 365 505 839 1 +555 273 497 618 1 +822 44 906 848 1 +91 428 313 495 1 +17 647 1024 516 1 +978 898 983 468 1 +326 73 222 989 1 +787 923 750 630 1 +496 548 311 312 1 +1005 448 604 563 1 +261 299 669 225 1 +540 210 682 1103 1 +274 357 128 282 1 +152 415 356 368 1 +814 501 402 1005 1 +248 116 867 621 1 +1109 599 486 1098 1 +662 515 209 584 1 +557 711 866 36 1 +603 348 338 617 1 +530 952 5 279 1 +188 801 463 412 1 +533 636 337 739 1 +893 1126 986 775 1 +614 844 516 418 1 +134 108 249 434 1 +332 166 396 587 1 +225 672 206 257 1 +696 798 402 467 1 +151 170 1140 1112 1 +281 535 32 578 1 +978 983 704 761 1 +1003 715 872 668 1 +846 1001 535 483 1 +270 241 469 305 1 +619 336 835 968 1 +795 267 602 453 1 +81 240 267 795 1 +93 477 85 344 1 +442 842 1073 1060 1 +404 536 1001 578 1 +77 474 551 272 1 +136 530 909 5 1 +437 323 348 492 1 +782 244 1147 277 1 +81 240 795 268 1 +476 799 154 675 1 +617 603 948 836 1 +483 1119 435 1064 1 +1062 858 55 261 1 +943 584 307 304 1 +581 442 1073 1060 1 +362 606 160 742 1 +480 1139 807 960 1 +893 354 538 890 1 +627 837 342 655 1 +45 195 196 804 1 +31 873 263 436 1 +1086 1110 358 999 1 +1017 319 335 3 1 +435 1119 709 1064 1 +372 403 383 334 1 +169 47 168 766 1 +60 393 118 327 1 +779 534 855 736 1 +281 1001 578 140 1 +797 311 884 365 1 +806 856 781 395 1 +1033 202 263 436 1 +1077 365 52 170 1 +498 107 490 146 1 +369 212 622 634 1 +60 393 151 118 1 +235 436 250 409 1 +77 115 325 352 1 +46 496 87 644 1 +758 328 371 903 1 +449 41 498 293 1 +691 16 462 1011 1 +853 339 613 708 1 +671 555 390 1025 1 +514 485 810 105 1 +646 621 1144 284 1 +510 775 1126 331 1 +644 1093 884 365 1 +428 488 495 344 1 +358 1087 218 582 1 +569 124 45 168 1 +826 192 388 575 1 +97 12 980 96 1 +21 95 420 973 1 +28 245 512 274 1 +241 414 469 305 1 +982 835 764 619 1 +17 647 516 844 1 +101 908 540 363 1 +504 996 445 1071 1 +106 280 483 130 1 +901 34 170 1140 1 +309 6 701 259 1 +515 713 597 352 1 +350 753 950 552 1 +516 418 844 1110 1 +613 339 1102 708 1 +548 789 311 966 1 +1096 1033 889 484 1 +609 991 628 940 1 +51 178 760 543 1 +578 128 718 32 1 +799 997 424 996 1 +188 801 550 463 1 +125 35 587 193 1 +1047 131 833 82 1 +1034 1089 848 1111 1 +63 229 260 932 1 +404 1001 345 292 1 +194 731 670 657 1 +180 507 857 715 1 +2 126 530 136 1 +2 102 530 126 1 +560 649 347 875 1 +728 806 581 416 1 +385 479 966 633 1 +12 129 532 5 1 +94 129 533 12 1 +29 130 535 32 1 +731 933 670 322 1 +358 582 218 310 1 +603 348 617 948 1 +846 949 780 718 1 +66 133 539 62 1 +146 490 960 664 1 +434 13 249 473 1 +826 43 388 192 1 +230 63 541 299 1 +1122 1043 406 579 1 +960 449 351 490 1 +1016 1094 977 892 1 +251 92 85 344 1 +60 171 151 393 1 +536 441 541 345 1 +77 115 352 474 1 +694 464 1005 448 1 +855 444 1078 751 1 +499 296 7 661 1 +191 190 166 452 1 +1148 56 470 859 1 +518 524 327 559 1 +456 836 1021 982 1 +846 578 954 702 1 +830 579 1122 491 1 +182 1003 668 373 1 +327 118 543 355 1 +1073 1060 834 975 1 +958 543 355 961 1 +431 763 1027 864 1 +248 116 72 867 1 +496 86 87 311 1 +205 244 794 652 1 +340 214 821 294 1 +963 506 607 106 1 +113 561 562 67 1 +543 42 355 961 1 +880 673 631 957 1 +71 76 115 629 1 +378 43 388 826 1 +263 202 235 436 1 +1045 127 1096 376 1 +840 608 685 566 1 +341 335 871 911 1 +825 87 349 144 1 +685 566 266 682 1 +649 319 1017 3 1 +1071 553 716 870 1 +963 321 41 607 1 +313 353 450 639 1 +754 996 997 634 1 +523 64 518 421 1 +1052 596 848 1111 1 +452 43 388 378 1 +1017 875 649 1020 1 +627 342 768 926 1 +266 303 566 239 1 +977 808 1092 36 1 +85 241 477 270 1 +932 229 1064 709 1 +356 754 1030 1011 1 +371 546 827 438 1 +1078 477 444 469 1 +826 192 575 778 1 +349 28 825 255 1 +191 43 826 192 1 +721 1133 478 461 1 +153 152 368 7 1 +122 27 576 152 1 +540 511 653 1103 1 +992 662 1016 515 1 +188 187 169 550 1 +814 1005 402 798 1 +828 83 556 148 1 +580 294 742 216 1 +1043 579 1023 854 1 +89 583 156 222 1 +1062 925 853 858 1 +456 628 733 617 1 +314 364 162 73 1 +270 241 477 469 1 +459 457 891 205 1 +1020 875 649 461 1 +662 660 597 956 1 +124 334 372 383 1 +83 828 1075 495 1 +139 84 92 344 1 +493 586 817 317 1 +598 572 401 967 1 +475 1133 970 886 1 +588 358 218 310 1 +862 398 774 829 1 +940 424 799 831 1 +375 477 85 93 1 +362 591 273 11 1 +200 1116 1108 309 1 +403 16 332 405 1 +1122 980 532 952 1 +167 186 831 20 1 +467 807 400 696 1 +634 212 142 184 1 +987 236 820 301 1 +491 319 904 335 1 +893 959 408 1126 1 +955 238 204 254 1 +727 275 1134 653 1 +376 755 1045 808 1 +31 234 263 873 1 +1115 331 1106 759 1 +427 467 425 817 1 +1121 1026 1056 740 1 +314 163 559 942 1 +834 1060 951 439 1 +751 477 270 375 1 +281 199 1001 292 1 +267 203 241 602 1 +461 219 896 645 1 +167 432 366 831 1 +1109 39 1128 589 1 +624 380 467 1005 1 +321 490 1024 351 1 +23 738 704 930 1 +312 548 360 947 1 +239 303 566 608 1 +483 846 1001 536 1 +86 28 311 610 1 +467 766 400 807 1 +86 28 610 274 1 +964 390 9 637 1 +314 942 73 163 1 +1135 1099 1094 625 1 +532 1063 129 739 1 +6 259 732 701 1 +299 63 541 626 1 +336 659 343 1115 1 +1003 872 80 438 1 +893 408 986 1126 1 +195 620 168 197 1 +964 1116 1044 701 1 +349 87 644 144 1 +544 950 1042 753 1 +95 24 616 145 1 +690 1029 1009 65 1 +2 335 341 909 1 +1022 677 865 779 1 +428 65 495 488 1 +1035 624 197 402 1 +195 59 620 197 1 +565 421 381 667 1 +71 629 1143 117 1 +31 263 235 436 1 +569 620 624 168 1 +495 428 313 65 1 +221 921 61 741 1 +142 504 622 634 1 +557 43 388 452 1 +576 462 356 415 1 +27 623 122 372 1 +576 462 415 463 1 +168 197 400 47 1 +738 1067 23 442 1 +142 4 1065 810 1 +667 381 373 389 1 +196 194 61 426 1 +995 721 499 582 1 +520 114 325 531 1 +976 859 413 879 1 +33 317 971 817 1 +344 477 693 1075 1 +436 558 566 303 1 +1 632 843 256 1 +182 121 635 176 1 +299 541 669 1118 1 +343 767 18 926 1 +854 497 638 591 1 +783 665 399 748 1 +257 639 686 78 1 +197 402 458 640 1 +928 33 564 769 1 +443 754 184 368 1 +556 494 387 148 1 +276 211 1120 1046 1 +241 602 477 469 1 +873 659 436 558 1 +797 311 19 811 1 +1070 468 1100 1012 1 +9 618 390 555 1 +791 656 739 905 1 +645 256 212 296 1 +645 219 256 296 1 +87 46 644 144 1 +372 367 383 425 1 +210 685 266 682 1 +779 534 677 865 1 +46 496 644 312 1 +381 689 518 1128 1 +888 655 837 784 1 +673 631 44 536 1 +629 520 325 58 1 +873 659 558 650 1 +601 925 1102 672 1 +153 122 356 152 1 +83 1075 93 495 1 +605 188 367 550 1 +1004 756 1088 878 1 +531 114 325 990 1 +212 632 622 142 1 +182 389 373 668 1 +372 367 124 383 1 +391 1046 1120 814 1 +959 99 392 354 1 +398 656 812 460 1 +614 770 949 1031 1 +368 212 7 499 1 +597 662 515 352 1 +540 511 1103 682 1 +413 377 459 652 1 +360 853 548 542 1 +411 564 425 464 1 +122 576 356 152 1 +752 1057 1077 1013 1 +336 1115 1106 759 1 +368 356 850 415 1 +1079 1055 1027 816 1 +755 1096 681 376 1 +1059 391 867 897 1 +428 488 344 1068 1 +1059 246 391 1046 1 +654 189 661 7 1 +567 1083 574 868 1 +510 1136 413 652 1 +46 496 312 89 1 +581 806 395 856 1 +789 954 938 702 1 +962 779 865 855 1 +283 953 132 284 1 +1123 839 505 901 1 +241 602 251 477 1 +1096 484 286 202 1 +496 938 548 947 1 +1132 422 254 21 1 +80 872 725 1101 1 +583 858 222 55 1 +374 429 39 805 1 +609 1058 22 568 1 +730 919 681 376 1 +234 271 948 873 1 +1126 408 986 510 1 +206 686 735 494 1 +1038 1006 23 824 1 +677 668 589 371 1 +899 785 935 625 1 +606 447 724 179 1 +1 103 319 347 1 +947 88 938 417 1 +476 675 154 220 1 +558 862 774 608 1 +183 503 48 653 1 +1075 861 537 534 1 +913 1126 730 539 1 +1064 880 673 631 1 +200 1116 527 1108 1 +478 698 611 765 1 +247 96 11 406 1 +243 455 457 684 1 +348 711 36 338 1 +915 776 1031 1104 1 +79 494 387 556 1 +277 521 410 697 1 +64 119 518 328 1 +920 104 757 10 1 +22 396 378 316 1 +554 573 604 897 1 +1106 984 1028 935 1 +939 653 48 275 1 +279 952 138 247 1 +995 499 1087 582 1 +611 1036 1008 945 1 +817 464 448 1005 1 +968 1028 655 342 1 +689 381 668 589 1 +2 335 909 530 1 +730 681 1074 376 1 +563 322 352 147 1 +753 881 950 552 1 +241 251 85 477 1 +1136 510 413 819 1 +698 691 824 598 1 +570 800 99 392 1 +15 185 153 443 1 +495 84 91 428 1 +627 917 768 342 1 +340 821 839 901 1 +668 589 779 677 1 +895 317 824 1006 1 +705 733 678 617 1 +916 1014 619 764 1 +234 285 202 1033 1 +475 1026 945 746 1 +240 77 287 749 1 +1029 53 818 324 1 +272 474 551 209 1 +145 24 744 699 1 +496 38 938 88 1 +354 522 538 772 1 +382 550 47 1139 1 +1085 510 730 891 1 +523 524 118 518 1 +1108 228 1084 249 1 +881 1023 14 638 1 +577 936 915 906 1 +713 597 448 586 1 +838 585 158 113 1 +280 41 1119 229 1 +850 356 368 754 1 +401 967 415 1030 1 +873 836 650 820 1 +513 646 816 763 1 +783 874 22 568 1 +347 1 843 875 1 +988 451 783 1146 1 +937 1076 720 834 1 +392 888 1000 908 1 +573 1089 924 493 1 +117 1143 159 501 1 +375 477 270 85 1 +471 526 979 183 1 +454 687 220 722 1 +703 856 39 416 1 +775 510 869 331 1 +299 300 626 231 1 +570 908 1091 101 1 +631 932 1064 880 1 +649 320 3 716 1 +69 570 1091 101 1 +176 175 438 80 1 +270 305 469 224 1 +466 955 545 1138 1 +807 1139 696 960 1 +1146 1058 849 851 1 +139 1068 84 344 1 +452 22 378 803 1 +63 260 230 541 1 +280 483 281 199 1 +300 1007 201 232 1 +230 441 292 345 1 +1121 740 1056 765 1 +371 487 903 53 1 +1053 691 824 971 1 +895 740 1037 1104 1 +280 483 130 281 1 +522 69 392 1091 1 +582 499 218 296 1 +316 769 378 803 1 +886 732 461 658 1 +461 886 658 721 1 +443 368 153 356 1 +302 1132 420 21 1 +471 526 1000 979 1 +675 733 20 306 1 +711 617 348 628 1 +888 784 1000 908 1 +437 384 492 40 1 +135 76 116 621 1 +197 402 1124 458 1 +793 1045 323 36 1 +888 893 538 775 1 +512 255 245 28 1 +903 328 689 663 1 +1117 929 567 688 1 +644 496 87 311 1 +822 44 848 957 1 +487 79 173 387 1 +1012 914 881 1041 1 +727 1134 1088 756 1 +880 1064 673 847 1 +404 536 345 1001 1 +378 22 316 803 1 +36 977 808 852 1 +1106 869 876 331 1 +605 372 425 367 1 +346 54 409 682 1 +768 342 842 926 1 +634 504 622 369 1 +457 243 253 205 1 +434 792 885 1084 1 +604 448 700 573 1 +1090 485 871 706 1 +59 1035 197 640 1 +196 125 411 587 1 +559 328 119 315 1 +434 885 473 1084 1 +416 674 374 917 1 +353 148 690 735 1 +407 1083 1010 1022 1 +1093 312 884 1081 1 +1044 227 6 308 1 +250 100 54 346 1 +494 686 735 148 1 +920 485 454 757 1 +831 186 675 20 1 +122 443 153 356 1 +585 388 158 900 1 +409 250 346 922 1 +349 214 340 642 1 +1004 398 829 774 1 +45 125 804 196 1 +208 492 348 143 1 +381 429 373 423 1 +307 921 741 209 1 +305 81 414 269 1 +496 938 789 548 1 +1034 915 1104 776 1 +311 312 548 884 1 +769 411 464 564 1 +606 179 742 34 1 +65 313 450 428 1 +399 1038 1014 815 1 +988 316 22 803 1 +1105 850 654 499 1 +356 850 415 1030 1 +687 456 733 617 1 +890 423 666 779 1 +292 88 55 417 1 +544 760 674 1042 1 +600 1141 615 1148 1 +658 473 228 219 1 +615 386 879 859 1 +141 66 100 484 1 +1097 1023 337 714 1 +58 600 481 531 1 +291 446 137 253 1 +618 497 854 591 1 +1015 728 416 806 1 +240 287 203 453 1 +487 53 371 677 1 +1046 211 246 276 1 +827 79 556 175 1 +589 39 1022 1109 1 +22 711 874 866 1 +306 733 678 705 1 +388 192 158 900 1 +353 495 65 690 1 +91 428 90 313 1 +982 874 946 1090 1 +786 254 739 985 1 +1078 469 981 782 1 +681 913 730 539 1 +885 358 588 310 1 +26 664 525 790 1 +419 974 548 954 1 +227 198 247 318 1 +1137 528 15 813 1 +871 911 882 656 1 +257 639 206 686 1 +509 99 354 522 1 +664 801 525 790 1 +2 530 909 136 1 +1044 318 227 390 1 +570 908 392 1091 1 +235 202 250 436 1 +955 812 791 1138 1 +992 683 894 643 1 +498 146 960 213 1 +485 476 454 687 1 +969 65 488 1131 1 +817 564 425 427 1 +637 618 318 390 1 +381 1128 518 565 1 +621 116 1059 117 1 +60 163 393 559 1 +381 518 421 565 1 +103 102 1 319 1 +364 641 53 903 1 +598 379 895 1037 1 +828 690 861 495 1 +517 990 453 287 1 +400 1139 696 807 1 +370 796 699 177 1 +509 99 522 149 1 +300 626 1007 262 1 +471 70 526 183 1 +348 617 678 628 1 +575 61 933 426 1 +1041 914 638 497 1 +320 716 1133 611 1 +1089 493 802 1111 1 +663 689 486 781 1 +649 319 3 347 1 +64 524 518 119 1 +771 883 816 626 1 +327 118 518 543 1 +448 464 597 322 1 +115 76 114 520 1 +956 575 892 1016 1 +121 330 389 421 1 +910 586 924 894 1 +944 687 706 757 1 +518 119 559 328 1 +555 497 854 618 1 +440 517 688 602 1 +283 513 284 201 1 +1097 420 350 714 1 +115 114 77 325 1 +975 1060 834 439 1 +495 83 828 148 1 +531 520 554 58 1 +651 302 608 1088 1 +757 687 454 301 1 +775 49 893 1126 1 +1097 1023 714 350 1 +587 826 378 426 1 +483 846 536 435 1 +775 538 1028 666 1 +775 962 666 547 1 +871 1071 485 851 1 +69 570 99 392 1 +587 191 826 193 1 +35 191 587 193 1 +1138 466 955 812 1 +447 359 914 881 1 +565 429 39 374 1 +169 187 47 550 1 +414 81 377 269 1 +221 921 741 307 1 +230 292 1062 345 1 +1110 719 995 844 1 +6 732 1044 701 1 +113 585 158 562 1 +136 786 909 104 1 +685 651 239 608 1 +1058 397 424 366 1 +996 849 424 851 1 +917 805 374 39 1 +324 601 613 1102 1 +506 29 106 963 1 +111 50 793 143 1 +705 437 208 492 1 +15 185 397 167 1 +769 316 411 564 1 +770 17 844 1056 1 +420 616 1097 350 1 +268 1141 470 859 1 +230 1062 55 261 1 +493 817 700 467 1 +437 348 208 492 1 +472 478 1105 401 1 +580 606 216 742 1 +413 919 876 510 1 +420 616 350 145 1 +340 214 839 821 1 +407 1067 984 574 1 +26 506 107 607 1 +574 56 625 984 1 +992 597 713 683 1 +1083 440 1131 929 1 +725 697 207 297 1 +768 342 703 842 1 +436 558 922 566 1 +567 864 481 929 1 +1019 506 607 963 1 +809 1130 3 347 1 +1136 927 981 469 1 +64 524 523 518 1 +277 509 410 521 1 +457 684 446 253 1 +299 63 626 300 1 +93 477 1075 375 1 +411 587 769 426 1 +327 543 42 355 1 +449 498 213 293 1 +493 700 802 798 1 +118 393 355 327 1 +257 231 1142 78 1 +178 37 177 1002 1 +277 509 521 207 1 +413 976 919 891 1 +140 88 1001 578 1 +531 833 481 864 1 +857 772 507 1000 1 +786 104 791 909 1 +347 320 3 649 1 +913 1126 331 730 1 +457 243 684 253 1 +888 784 745 655 1 +953 763 864 646 1 +1019 108 434 999 1 +446 457 253 205 1 +515 551 209 272 1 +152 576 356 415 1 +305 414 927 269 1 +835 767 18 343 1 +225 299 1118 771 1 +281 578 32 140 1 +638 724 160 606 1 +1137 443 356 405 1 +484 66 100 346 1 +702 966 385 610 1 +542 419 548 811 1 +735 1069 173 487 1 +487 735 1069 690 1 +50 519 111 793 1 +287 990 453 749 1 +446 684 455 67 1 +908 682 54 346 1 +206 494 735 737 1 +1076 945 1020 1008 1 +265 264 545 237 1 +1136 470 819 413 1 +479 512 527 610 1 +345 541 594 1118 1 +417 404 853 1062 1 +540 210 363 682 1 +691 16 427 1095 1 +707 1143 1035 159 1 +230 199 292 441 1 +1085 730 133 291 1 +410 99 354 509 1 +291 446 253 205 1 +13 885 588 310 1 +392 49 908 1061 1 +810 485 476 105 1 +1067 935 998 571 1 +617 628 711 456 1 +1110 995 358 844 1 +1110 647 719 844 1 +503 165 164 48 1 +891 652 794 408 1 +726 1082 1117 440 1 +164 183 503 48 1 +615 1129 749 515 1 +1029 1069 53 324 1 +480 801 647 1072 1 +89 583 222 55 1 +690 828 387 148 1 +1021 1090 430 706 1 +270 477 1078 469 1 +287 517 990 288 1 +393 1077 752 1057 1 +557 838 793 36 1 +521 725 890 736 1 +366 609 1058 22 1 +948 617 820 271 1 +542 1048 884 360 1 +1062 292 404 345 1 +1106 1028 968 935 1 +453 287 203 517 1 +437 323 492 384 1 +931 810 8 154 1 +122 372 356 576 1 +63 229 932 262 1 +130 963 535 483 1 +762 208 348 143 1 +685 651 840 1103 1 +454 687 722 301 1 +125 587 773 411 1 +355 901 961 1112 1 +107 664 607 490 1 +235 436 566 303 1 +443 997 754 397 1 +75 509 410 277 1 +797 505 1070 1123 1 +18 764 460 982 1 +231 626 593 300 1 +1004 420 1088 829 1 +839 214 144 170 1 +773 403 334 383 1 +317 586 924 493 1 +372 403 405 16 1 +840 829 608 774 1 +1138 820 1021 944 1 +424 849 1011 1058 1 +894 586 924 317 1 +18 650 1021 1138 1 +652 244 269 205 1 +1136 377 413 652 1 +934 242 386 304 1 +542 884 811 548 1 +959 354 888 893 1 +1111 798 596 379 1 +1011 1146 698 691 1 +31 873 436 558 1 +491 1017 637 1020 1 +601 641 1069 324 1 +118 51 543 150 1 +805 784 888 837 1 +771 433 816 883 1 +524 60 327 559 1 +955 238 254 985 1 +988 783 22 568 1 +673 1052 848 957 1 +1083 929 1131 567 1 +511 756 887 674 1 +193 191 826 192 1 +341 335 911 909 1 +955 265 237 204 1 +1068 139 1054 747 1 +939 540 210 161 1 +802 700 897 814 1 +167 185 397 432 1 +471 979 1000 511 1 +882 1071 871 430 1 +962 986 775 893 1 +1146 1050 698 824 1 +934 268 859 242 1 +622 504 320 369 1 +45 195 804 569 1 +1050 399 815 824 1 +840 566 685 682 1 +312 360 583 947 1 +917 511 805 887 1 +176 174 546 175 1 +1133 845 1020 886 1 +1095 807 605 1039 1 +366 424 940 831 1 +863 894 910 567 1 +444 751 855 865 1 +980 1043 952 1122 1 +514 871 485 920 1 +339 972 692 695 1 +120 330 329 918 1 +163 172 942 73 1 +373 715 423 772 1 +237 236 987 301 1 +858 261 222 55 1 +907 51 120 165 1 +907 165 120 164 1 +947 360 583 417 1 +907 165 164 503 1 +311 644 884 365 1 +374 511 805 917 1 +1124 729 1127 295 1 +955 238 265 204 1 +1057 942 1013 559 1 +1083 1032 860 868 1 +367 27 124 169 1 +976 859 879 386 1 +874 338 711 456 1 +169 550 47 382 1 +452 22 803 866 1 +290 1085 291 891 1 +101 908 363 54 1 +391 787 1079 897 1 +153 152 356 368 1 +188 463 576 412 1 +80 725 207 297 1 +522 857 521 149 1 +369 212 184 368 1 +721 478 560 461 1 +1057 172 171 1077 1 +687 617 733 705 1 +553 851 430 946 1 +1060 465 768 439 1 +1088 302 1132 420 1 +121 74 635 176 1 +1036 489 1026 740 1 +297 1101 1078 270 1 +497 606 216 580 1 +909 739 1063 905 1 +59 620 197 1035 1 +118 393 151 355 1 +1105 415 654 850 1 +391 1046 246 276 1 +188 25 187 550 1 +405 372 462 356 1 +277 297 697 224 1 +201 593 816 300 1 +797 311 365 1123 1 +496 88 947 89 1 +336 968 343 835 1 +15 443 153 122 1 +372 462 356 576 1 +33 956 928 643 1 +638 14 854 1023 1 +282 718 32 134 1 +857 1000 507 70 1 +373 668 423 715 1 +984 407 1010 666 1 +665 916 399 1014 1 +997 996 8 634 1 +822 500 818 906 1 +32 38 140 578 1 +904 911 530 952 1 +805 784 1000 888 1 +405 1137 372 356 1 +642 214 340 294 1 +1000 70 526 471 1 +394 902 966 1031 1 +232 233 1007 1079 1 +462 1011 16 405 1 +281 483 535 1001 1 +69 1091 526 161 1 +923 729 750 449 1 +761 806 395 581 1 +443 368 184 153 1 +644 46 1093 144 1 +119 314 162 163 1 +225 231 771 1142 1 +499 850 368 369 1 +392 1000 1091 908 1 +602 747 517 251 1 +1085 510 1126 730 1 +1138 812 791 430 1 +217 308 1116 245 1 +18 659 836 650 1 +562 943 900 221 1 +608 238 1066 985 1 +854 638 1043 591 1 +585 900 158 562 1 +493 586 700 817 1 +783 916 568 1050 1 +721 461 560 645 1 +1116 701 479 1108 1 +536 541 631 594 1 +217 1025 1116 308 1 +619 968 764 1014 1 +810 476 154 105 1 +150 1114 679 179 1 +644 496 311 312 1 +928 564 988 769 1 +79 173 387 494 1 +770 970 792 475 1 +797 1070 549 1123 1 +630 932 709 262 1 +834 439 720 937 1 +680 7 654 368 1 +83 157 93 1075 1 +819 413 879 876 1 +937 1076 834 1073 1 +812 951 18 774 1 +33 317 817 586 1 +5 12 138 532 1 +545 264 987 237 1 +813 332 166 396 1 +816 513 593 201 1 +197 624 400 402 1 +558 767 18 650 1 +374 511 674 503 1 +397 1058 813 396 1 +798 696 807 467 1 +996 849 851 870 1 +518 329 421 565 1 +650 820 1021 1138 1 +63 626 932 541 1 +147 731 352 474 1 +1145 78 593 283 1 +952 96 247 406 1 +317 894 586 683 1 +1117 1082 1010 865 1 +565 416 374 39 1 +850 754 369 472 1 +44 847 673 536 1 +113 1092 838 585 1 +431 1080 864 567 1 +597 322 662 352 1 +775 986 547 869 1 +743 864 481 567 1 +1090 991 687 456 1 +693 1075 534 861 1 +498 146 490 960 1 +346 66 100 1061 1 +795 240 267 453 1 +304 386 584 242 1 +50 838 158 113 1 +944 1138 791 706 1 +365 644 1093 144 1 +483 41 1119 280 1 +307 584 209 272 1 +287 517 288 203 1 +748 769 892 956 1 +1028 655 837 888 1 +1073 975 834 937 1 +234 285 734 384 1 +455 386 993 943 1 +1086 790 358 1110 1 +782 927 981 1147 1 +775 890 666 962 1 +561 455 993 943 1 +26 506 607 1086 1 +623 334 372 124 1 +514 871 920 341 1 +560 896 843 645 1 +795 240 453 1141 1 +457 459 243 205 1 +307 584 272 242 1 +761 395 806 468 1 +278 335 530 904 1 +719 415 1105 401 1 +126 278 530 279 1 +881 544 728 753 1 +846 614 847 435 1 +962 855 981 736 1 +98 290 408 1085 1 +458 1124 47 1127 1 +345 708 1062 669 1 +364 942 972 73 1 +620 624 197 1035 1 +38 128 938 578 1 +89 417 583 55 1 +151 1140 958 355 1 +1052 596 1111 802 1 +1087 525 155 661 1 +629 520 58 554 1 +775 890 538 666 1 +562 900 158 221 1 +327 518 42 543 1 +518 524 118 327 1 +42 329 518 565 1 +682 566 409 994 1 +417 1062 858 55 1 +240 749 1141 1129 1 +1102 500 818 822 1 +258 198 227 318 1 +544 753 1042 674 1 +141 100 250 484 1 +387 79 556 827 1 +989 595 73 298 1 +454 476 154 220 1 +1137 403 405 372 1 +494 173 735 737 1 +1080 969 864 1131 1 +729 213 1127 295 1 +642 255 512 349 1 +166 191 452 378 1 +324 641 692 339 1 +903 364 162 315 1 +904 406 637 491 1 +535 963 846 483 1 +516 607 418 1019 1 +780 792 712 633 1 +1130 347 809 1065 1 +152 680 415 368 1 +1007 201 816 300 1 +1060 842 951 768 1 +949 633 780 385 1 +18 764 951 460 1 +257 1142 639 78 1 +812 862 774 466 1 +577 906 1032 818 1 +881 914 638 1041 1 +243 455 684 304 1 +621 1059 554 117 1 +944 1021 1138 706 1 +243 934 455 304 1 +15 185 443 397 1 +418 1019 1110 516 1 +261 230 669 299 1 +960 213 729 449 1 +181 70 180 507 1 +993 943 386 1016 1 +181 180 182 507 1 +1037 1104 596 1111 1 +1030 754 849 1011 1 +499 296 661 218 1 +499 212 7 296 1 +1137 30 528 813 1 +897 1059 391 1046 1 +664 146 25 333 1 +143 50 793 557 1 +495 861 1075 693 1 +590 945 1076 1036 1 +508 12 980 97 1 +762 348 793 143 1 +1022 423 779 666 1 +812 862 466 955 1 +206 601 735 353 1 +590 965 761 549 1 +152 188 412 189 1 +370 878 145 796 1 +472 401 1030 698 1 +58 573 554 743 1 +1077 365 170 1112 1 +479 701 964 886 1 +18 650 1138 466 1 +30 528 813 123 1 +188 27 367 169 1 +196 587 411 426 1 +196 193 587 426 1 +396 1058 22 366 1 +1073 704 581 761 1 +934 269 243 459 1 +749 77 352 551 1 +91 84 90 428 1 +50 557 838 793 1 +1031 966 394 949 1 +610 479 966 385 1 +1114 447 1002 359 1 +1036 777 1008 1076 1 +919 331 681 1115 1 +1115 919 331 759 1 +678 348 208 437 1 +67 455 561 562 1 +623 30 122 372 1 +12 129 533 532 1 +832 642 1113 671 1 +176 175 546 438 1 +1079 957 1007 816 1 +859 1129 615 386 1 +1037 1104 1111 895 1 +868 574 894 899 1 +95 94 21 420 1 +990 325 600 749 1 +215 973 302 878 1 +1080 431 1034 924 1 +860 486 1032 599 1 +143 50 557 43 1 +1024 321 351 676 1 +536 954 578 404 1 +1035 1143 501 159 1 +935 612 1014 968 1 +665 916 783 399 1 +405 372 16 462 1 +315 663 328 903 1 +949 966 633 385 1 +959 392 49 888 1 +260 199 230 441 1 +811 902 311 19 1 +557 762 711 36 1 +515 352 662 551 1 +309 701 1108 228 1 +419 954 548 902 1 +83 84 495 93 1 +83 828 157 1075 1 +762 348 36 793 1 +282 712 249 200 1 +1007 262 630 233 1 +252 104 10 757 1 +642 255 214 294 1 +603 659 835 336 1 +444 751 865 693 1 +478 472 1105 369 1 +906 936 915 776 1 +44 500 974 708 1 +851 424 1058 849 1 +795 1141 453 470 1 +4 2 514 105 1 +804 195 196 670 1 +290 1085 133 291 1 +94 21 420 1132 1 +1071 851 430 553 1 +164 183 471 503 1 +274 357 282 527 1 +425 383 411 380 1 +502 808 1092 977 1 +890 779 962 736 1 +851 485 871 1090 1 +546 175 827 438 1 +545 650 558 466 1 +622 320 560 369 1 +564 332 16 988 1 +603 323 348 948 1 +215 878 1134 796 1 +743 431 567 924 1 +475 1026 746 633 1 +316 332 411 564 1 +484 250 1033 922 1 +792 633 475 886 1 +1133 970 886 721 1 +338 603 36 348 1 +453 203 602 517 1 +384 323 948 437 1 +426 193 826 778 1 +719 412 654 415 1 +769 803 928 748 1 +138 532 980 952 1 +804 125 411 196 1 +614 17 844 770 1 +497 642 1123 580 1 +440 481 688 517 1 +378 826 575 426 1 +286 681 62 484 1 +499 654 661 7 1 +919 1115 681 808 1 +761 549 965 1070 1 +537 751 1101 223 1 +909 791 739 905 1 +898 781 395 468 1 +485 445 810 476 1 +855 751 534 865 1 +765 719 995 401 1 +687 456 617 820 1 +996 472 849 870 1 +578 417 1001 404 1 +984 666 571 407 1 +119 559 314 163 1 +736 297 224 697 1 +1116 671 479 964 1 +537 175 157 223 1 +479 845 475 886 1 +771 299 626 231 1 +51 178 543 150 1 +627 727 840 1004 1 +823 983 860 1098 1 +639 450 313 433 1 +500 339 542 853 1 +738 915 489 930 1 +775 510 986 869 1 +181 70 507 471 1 +1041 1012 1040 912 1 +246 1059 391 72 1 +805 511 784 887 1 +1104 740 915 930 1 +481 747 833 517 1 +190 20 678 208 1 +163 171 393 1057 1 +350 145 744 370 1 +122 30 1137 372 1 +318 406 637 904 1 +452 762 628 711 1 +778 192 575 788 1 +577 906 738 1032 1 +215 973 878 796 1 +752 841 695 884 1 +781 841 752 961 1 +752 355 42 961 1 +99 69 522 149 1 +1142 231 771 593 1 +1096 202 1033 484 1 +698 824 717 611 1 +65 693 1131 1009 1 +452 366 22 628 1 +668 381 423 589 1 +1072 807 605 1095 1 +859 879 56 819 1 +268 859 470 934 1 +686 91 353 148 1 +651 302 239 608 1 +840 651 608 1088 1 +774 558 767 18 1 +1123 505 1070 912 1 +577 486 818 1032 1 +524 60 559 119 1 +434 29 108 1019 1 +1010 574 56 1117 1 +517 833 990 288 1 +544 359 1002 950 1 +452 190 166 592 1 +136 104 252 786 1 +215 302 651 1088 1 +843 896 256 645 1 +1040 359 1012 914 1 +517 600 453 990 1 +372 383 16 425 1 +743 1089 924 573 1 +81 795 241 414 1 +1035 402 197 640 1 +811 468 978 965 1 +113 585 562 561 1 +694 707 563 1035 1 +449 1119 709 435 1 +709 1119 293 229 1 +795 602 414 470 1 +912 580 497 1123 1 +295 293 233 750 1 +215 651 1134 1088 1 +688 602 726 440 1 +909 791 786 739 1 +416 1128 39 565 1 +561 455 1092 993 1 +641 173 73 737 1 +567 894 910 924 1 +994 558 922 767 1 +542 695 841 884 1 +457 684 455 446 1 +130 535 32 281 1 +833 747 1054 288 1 +1086 790 1110 516 1 +942 326 972 73 1 +279 952 5 138 1 +112 1045 519 1092 1 +470 377 1136 414 1 +874 609 22 568 1 +1115 913 889 655 1 +725 297 1101 736 1 +239 238 608 302 1 +188 25 801 189 1 +301 944 687 820 1 +289 254 786 204 1 +164 181 471 183 1 +887 727 1004 756 1 +1008 882 716 1017 1 +61 788 575 921 1 +652 459 891 205 1 +350 420 1004 714 1 +249 108 13 434 1 +436 566 922 409 1 +392 959 49 1061 1 +799 186 154 675 1 +174 79 173 487 1 +580 294 34 742 1 +1056 1104 1031 17 1 +471 979 511 503 1 +945 1036 1008 1076 1 +93 84 344 92 1 +1051 875 198 904 1 +285 1096 127 286 1 +609 874 22 628 1 +344 477 1075 93 1 +991 874 628 456 1 +838 519 1092 113 1 +1079 816 1027 957 1 +523 421 329 330 1 +634 142 8 184 1 +405 988 332 1058 1 +1113 1123 549 497 1 +418 1019 999 1110 1 +288 723 139 1054 1 +1128 689 518 42 1 +182 1003 373 507 1 +789 702 357 610 1 +438 175 537 223 1 +298 672 206 225 1 +996 369 754 472 1 +832 642 1123 1113 1 +997 754 424 996 1 +167 186 432 831 1 +1003 872 438 668 1 +1110 1087 358 995 1 +59 620 1035 694 1 +377 269 934 459 1 +463 480 550 605 1 +739 985 636 812 1 +895 1006 824 740 1 +1001 88 292 417 1 +1006 23 824 740 1 +274 527 282 200 1 +1112 752 961 355 1 +813 166 123 167 1 +1084 479 712 633 1 +325 629 713 352 1 +496 938 86 789 1 +658 259 896 219 1 +1072 647 379 572 1 +70 180 857 149 1 +1099 1094 879 992 1 +438 175 223 80 1 +903 663 364 315 1 +851 609 940 991 1 +812 430 656 791 1 +584 386 515 1129 1 +438 223 537 872 1 +1071 851 871 430 1 +33 564 464 817 1 +152 412 576 415 1 +914 1012 1040 1041 1 +224 244 782 277 1 +197 1124 47 458 1 +985 238 254 422 1 +543 518 42 329 1 +602 470 726 414 1 +1111 482 1053 895 1 +1129 386 859 242 1 +196 193 426 61 1 +307 921 943 221 1 +1081 1013 884 1077 1 +901 580 1123 340 1 +60 559 393 327 1 +60 559 119 163 1 +657 707 694 59 1 +130 483 535 281 1 +1116 390 1044 308 1 +481 747 1068 833 1 +529 403 334 773 1 +584 1129 272 242 1 +955 791 985 786 1 +853 974 548 419 1 +191 43 190 452 1 +191 43 452 378 1 +504 445 810 1130 1 +998 23 777 815 1 +281 292 1001 140 1 +817 1005 700 467 1 +455 934 386 304 1 +241 414 602 469 1 +9 555 854 618 1 +1007 1055 201 232 1 +571 666 856 823 1 +351 960 729 449 1 +772 521 354 522 1 +433 883 1145 816 1 +74 328 635 371 1 +1004 420 878 1088 1 +106 41 963 483 1 +181 70 471 183 1 +1014 612 785 748 1 +9 637 618 854 1 +883 631 594 44 1 +1015 543 329 907 1 +1055 201 816 1007 1 +234 40 384 948 1 +496 947 312 89 1 +1021 456 687 820 1 +83 556 157 828 1 +639 1018 450 433 1 +1032 822 1080 969 1 +607 664 1024 490 1 +941 829 398 636 1 +577 978 915 936 1 +167 831 166 20 1 +485 1071 1130 445 1 +436 31 558 303 1 +235 31 436 303 1 +313 495 65 353 1 +313 91 495 353 1 +91 495 353 148 1 +91 83 495 148 1 +105 2 920 104 1 +1042 760 877 1002 1 +235 250 54 409 1 +912 1123 505 901 1 +322 464 660 670 1 +1002 744 699 370 1 +1115 331 655 1106 1 +105 485 476 454 1 +577 860 983 486 1 +625 819 879 876 1 +91 90 78 313 1 +392 49 888 908 1 +698 849 472 870 1 +1066 303 265 238 1 +939 1103 653 275 1 +813 332 123 166 1 +888 354 538 893 1 +772 1000 538 805 1 +310 721 582 219 1 +349 365 839 144 1 +754 472 849 996 1 +1147 927 981 986 1 +746 965 590 549 1 +1010 407 574 1083 1 +909 530 532 5 1 +1010 407 984 574 1 +384 285 1096 127 1 +604 700 501 897 1 +615 879 1099 56 1 +1002 950 744 370 1 +1133 716 649 1020 1 +542 695 884 1048 1 +920 757 454 10 1 +896 1 843 256 1 +215 651 275 1134 1 +1097 533 337 980 1 +366 831 592 166 1 +531 864 481 743 1 +544 1002 760 1042 1 +365 752 884 505 1 +914 359 1012 881 1 +440 481 929 688 1 +850 401 415 1030 1 +1020 732 461 886 1 +168 620 624 197 1 +522 1091 1000 526 1 +516 1019 1110 1086 1 +557 762 793 143 1 +321 435 676 614 1 +81 795 377 268 1 +410 408 1147 893 1 +937 439 720 941 1 +396 332 316 988 1 +716 882 3 1017 1 +167 397 396 366 1 +689 1109 53 486 1 +359 544 543 1012 1 +1082 869 986 819 1 +28 512 610 274 1 +934 859 976 386 1 +998 1014 815 764 1 +875 319 1017 649 1 +400 47 1139 382 1 +981 927 1136 986 1 +788 192 221 61 1 +1116 1044 6 308 1 +726 56 819 470 1 +423 39 666 1022 1 +418 999 885 844 1 +59 670 620 694 1 +89 88 417 55 1 +790 719 1087 1110 1 +357 610 385 527 1 +787 295 233 750 1 +631 594 44 536 1 +310 582 218 296 1 +1123 797 19 549 1 +352 749 551 515 1 +948 437 617 271 1 +515 662 209 551 1 +1026 489 590 965 1 +704 983 442 395 1 +137 446 730 376 1 +449 490 321 351 1 +910 743 924 573 1 +733 831 628 940 1 +548 789 966 954 1 +616 350 744 552 1 +951 768 774 398 1 +921 788 943 221 1 +240 287 453 749 1 +990 600 453 749 1 +715 507 857 772 1 +973 21 302 420 1 +183 503 653 979 1 +83 84 91 495 1 +180 715 857 521 1 +758 174 173 487 1 +406 618 11 318 1 +232 233 1079 276 1 +542 884 548 360 1 +489 915 1026 740 1 +412 801 719 654 1 +410 1147 962 893 1 +1051 964 732 1020 1 +282 527 712 200 1 +558 659 767 650 1 +580 606 742 34 1 +640 402 458 159 1 +99 98 75 959 1 +94 21 1132 254 1 +592 628 762 678 1 +377 795 470 268 1 +81 795 414 377 1 +49 888 745 655 1 +33 683 597 956 1 +583 326 156 222 1 +199 280 1119 229 1 +95 616 420 145 1 +912 1070 549 1041 1 +411 670 464 804 1 +356 1030 415 462 1 +427 1095 807 1053 1 +652 413 510 891 1 +926 627 774 768 1 +1103 840 685 682 1 +485 445 476 991 1 +634 810 996 8 1 +579 406 1122 491 1 +320 472 478 369 1 +746 902 19 966 1 +840 608 558 774 1 +814 211 1125 1124 1 +720 830 882 1017 1 +396 1058 988 22 1 +1032 599 1009 1083 1 +241 203 251 602 1 +802 493 1089 700 1 +1034 1089 1111 482 1 +240 203 267 453 1 +258 318 227 1044 1 +114 990 531 131 1 +765 844 970 995 1 +712 434 1084 792 1 +1120 211 295 1125 1 +321 41 1119 963 1 +663 486 692 898 1 +22 874 711 628 1 +592 20 628 678 1 +56 819 879 625 1 +349 311 365 644 1 +694 670 464 322 1 +875 1 278 319 1 +904 875 278 319 1 +577 486 1032 860 1 +841 961 468 505 1 +758 174 487 371 1 +1080 763 957 431 1 +998 704 1073 777 1 +117 501 159 246 1 +429 772 373 423 1 +782 1147 410 277 1 +927 269 652 244 1 +785 399 971 1038 1 +737 595 641 735 1 +722 733 220 306 1 +729 213 750 449 1 +565 674 374 416 1 +67 455 562 304 1 +557 452 892 866 1 +1083 1117 865 440 1 +311 19 966 610 1 +537 827 157 175 1 +781 841 961 468 1 +445 799 476 940 1 +996 8 810 799 1 +440 477 444 693 1 +753 350 1004 714 1 +1057 1013 752 559 1 +343 655 926 968 1 +297 1101 270 223 1 +908 1000 1091 540 1 +740 1036 777 717 1 +999 885 588 13 1 +799 8 154 186 1 +926 842 951 968 1 +557 43 158 388 1 +50 557 43 158 1 +607 506 107 106 1 +1035 1005 402 501 1 +1104 740 1056 394 1 +1114 37 1002 447 1 +670 694 657 322 1 +735 595 641 601 1 +323 793 36 348 1 +980 533 337 532 1 +32 29 134 535 1 +291 730 62 1074 1 +36 603 852 808 1 +474 731 662 209 1 +339 500 818 1102 1 +201 593 283 513 1 +1101 1078 270 751 1 +815 1038 23 824 1 +772 857 522 1000 1 +66 539 484 62 1 +535 718 32 578 1 +638 914 606 497 1 +879 1094 386 992 1 +479 746 19 966 1 +901 580 1040 912 1 +608 303 1066 238 1 +902 915 1031 394 1 +901 1112 505 961 1 +441 1001 345 536 1 +930 489 1036 740 1 +1026 394 770 1056 1 +1118 44 822 883 1 +620 670 464 694 1 +1082 547 986 869 1 +523 118 51 329 1 +536 847 673 1064 1 +985 955 786 254 1 +736 1078 855 981 1 +696 814 1124 402 1 +440 747 517 602 1 +32 535 134 718 1 +629 554 604 117 1 +708 339 1102 500 1 +285 734 1096 1033 1 +119 315 74 162 1 +351 729 696 923 1 +1092 1045 36 808 1 +979 503 653 511 1 +377 269 459 652 1 +958 901 34 1040 1 +24 552 160 97 1 +817 467 425 380 1 +351 729 923 449 1 +1100 14 975 1049 1 +28 87 311 349 1 +518 381 328 689 1 +638 14 1041 854 1 +638 1041 497 854 1 +551 474 662 209 1 +41 490 449 498 1 +41 107 490 498 1 +380 766 569 624 1 +468 761 978 965 1 +869 547 775 666 1 +1081 1013 1077 172 1 +58 743 910 573 1 +1042 370 878 350 1 +349 214 839 340 1 +536 1064 673 631 1 +268 1129 859 242 1 +751 444 1078 477 1 +504 996 810 445 1 +470 453 602 1148 1 +506 29 1019 108 1 +843 632 622 212 1 +95 508 94 1097 1 +1033 250 436 922 1 +485 1090 687 706 1 +607 963 321 614 1 +906 1080 1034 1032 1 +679 359 543 961 1 +839 214 170 821 1 +180 521 725 715 1 +558 650 18 466 1 +686 91 313 353 1 +274 245 512 200 1 +610 512 527 274 1 +515 615 713 352 1 +28 512 349 610 1 +289 204 786 252 1 +1063 532 5 909 1 +577 915 978 738 1 +874 338 619 665 1 +1080 1131 1032 969 1 +364 692 53 641 1 +182 180 80 1003 1 +370 796 177 877 1 +913 745 655 49 1 +1117 1082 726 56 1 +15 813 167 397 1 +57 110 1045 127 1 +979 540 653 939 1 +289 786 909 136 1 +769 464 33 564 1 +178 1114 760 543 1 +74 174 162 758 1 +777 740 23 930 1 +452 762 711 557 1 +349 87 311 644 1 +326 172 156 222 1 +518 42 689 663 1 +769 660 575 956 1 +607 516 1024 664 1 +947 938 548 417 1 +803 665 783 748 1 +979 1000 511 540 1 +1107 951 460 834 1 +404 708 853 1062 1 +1046 402 501 159 1 +964 1044 318 1051 1 +511 727 887 756 1 +166 831 592 20 1 +18 926 774 951 1 +373 507 715 772 1 +163 1057 393 559 1 +584 515 209 272 1 +975 465 728 581 1 +139 344 251 747 1 +787 596 1052 802 1 +30 403 1137 372 1 +1134 651 275 727 1 +309 259 701 228 1 +374 471 805 511 1 +520 325 58 531 1 +860 407 1067 823 1 +111 110 40 384 1 +40 111 384 492 1 +161 979 183 939 1 +124 334 383 45 1 +1025 217 642 648 1 +801 525 1087 661 1 +670 194 196 426 1 +481 531 990 833 1 +89 947 583 417 1 +1088 1132 829 420 1 +935 612 785 1014 1 +623 30 372 334 1 +512 245 217 1116 1 +1067 899 935 984 1 +302 238 608 422 1 +409 250 54 346 1 +1058 609 851 568 1 +985 422 254 1132 1 +325 629 58 713 1 +63 932 260 541 1 +513 284 201 1055 1 +489 978 902 915 1 +908 682 346 994 1 +560 320 649 461 1 +84 428 344 1068 1 +567 894 924 868 1 +243 242 934 304 1 +582 645 296 219 1 +425 411 464 380 1 +566 608 558 840 1 +1037 1104 1056 17 1 +390 227 1044 308 1 +327 393 752 559 1 +393 1057 752 559 1 +699 724 744 37 1 +560 212 369 499 1 +744 24 552 724 1 +321 1119 449 435 1 +460 882 430 553 1 +622 320 347 560 1 +771 1118 883 594 1 +342 571 1028 837 1 +49 655 1028 888 1 +311 884 548 811 1 +471 183 979 503 1 +998 899 1038 935 1 +374 471 511 503 1 +992 1016 386 515 1 +785 899 1038 317 1 +569 367 168 766 1 +567 894 868 574 1 +449 293 630 709 1 +455 934 976 386 1 +102 278 335 530 1 +42 689 781 1128 1 +782 981 736 410 1 +657 707 563 694 1 +109 108 999 13 1 +477 251 85 344 1 +367 169 124 168 1 +336 759 1106 612 1 +637 9 964 845 1 +337 1122 905 830 1 +1146 824 698 691 1 +787 295 750 1125 1 +812 791 739 985 1 +755 681 808 376 1 +321 676 1024 614 1 +538 423 666 890 1 +892 1016 575 900 1 +1070 468 761 1100 1 +536 1001 1064 441 1 +1031 847 974 536 1 +868 1034 1032 738 1 +480 664 1024 647 1 +994 908 745 346 1 +1050 1146 783 399 1 +18 430 812 1138 1 +287 990 131 288 1 +882 553 720 1008 1 +729 213 295 750 1 +383 367 569 425 1 +190 592 762 678 1 +351 1024 379 480 1 +911 335 882 1017 1 +996 851 424 445 1 +128 718 32 282 1 +762 348 711 36 1 +776 419 1031 974 1 +239 303 608 238 1 +523 330 329 120 1 +199 483 1001 1064 1 +523 64 421 330 1 +947 548 360 417 1 +524 60 118 327 1 +682 266 54 409 1 +136 909 2 104 1 +225 299 771 231 1 +200 245 1116 309 1 +510 986 1136 652 1 +1148 726 470 56 1 +20 831 592 628 1 +2 102 335 530 1 +923 449 709 435 1 +1048 326 989 972 1 +528 15 813 123 1 +466 1138 545 650 1 +529 123 587 35 1 +234 285 1033 734 1 +1050 1146 698 553 1 +126 530 5 279 1 +65 861 693 1009 1 +51 178 165 760 1 +710 261 925 225 1 +1123 642 340 580 1 +391 814 897 1046 1 +76 131 531 1047 1 +76 114 531 131 1 +76 114 520 531 1 +543 51 907 760 1 +942 1013 364 972 1 +347 843 622 560 1 +854 1041 1049 14 1 +266 235 566 303 1 +926 951 18 968 1 +226 896 875 732 1 +320 369 478 560 1 +834 842 951 1060 1 +466 1066 545 955 1 +111 1045 384 323 1 +874 991 1090 456 1 +417 548 853 404 1 +1035 501 402 159 1 +555 1025 642 648 1 +638 1023 854 1043 1 +938 954 578 702 1 +703 917 768 465 1 +225 1142 672 257 1 +148 494 387 735 1 +412 463 576 415 1 +604 713 448 573 1 +684 304 455 67 1 +1147 986 962 893 1 +1029 818 1009 65 1 +101 540 161 210 1 +557 762 36 793 1 +145 616 350 744 1 +982 619 946 874 1 +101 540 210 363 1 +1060 768 951 439 1 +531 520 621 554 1 +1130 445 810 485 1 +423 668 779 715 1 +111 1045 110 384 1 +349 512 832 610 1 +929 481 567 688 1 +542 339 898 695 1 +406 318 247 904 1 +1052 1089 848 431 1 +1048 1013 326 972 1 +845 9 479 746 1 +721 461 645 219 1 +229 293 709 262 1 +545 873 650 987 1 +383 403 16 332 1 +383 773 332 411 1 +951 812 18 460 1 +1 103 347 632 1 +513 646 953 284 1 +868 1006 1034 738 1 +310 582 296 219 1 +667 918 389 68 1 +938 128 789 702 1 +31 545 265 264 1 +823 1098 860 1022 1 +598 379 1037 572 1 +870 553 717 698 1 +423 589 779 668 1 +743 58 531 554 1 +1132 985 636 533 1 +912 961 901 505 1 +346 913 1061 745 1 +226 732 875 1051 1 +306 733 20 678 1 +82 723 288 833 1 +511 653 727 756 1 +585 557 158 388 1 +171 170 151 1112 1 +545 873 558 650 1 +1131 1032 1009 1083 1 +787 814 897 391 1 +479 886 633 1084 1 +400 382 807 766 1 +1034 1080 868 1032 1 +381 389 635 668 1 +674 511 917 887 1 +989 613 595 925 1 +608 303 558 1066 1 +839 1112 901 170 1 +614 770 418 780 1 +803 22 665 866 1 +81 795 267 241 1 +655 922 767 994 1 +188 605 27 576 1 +1000 857 522 526 1 +518 64 328 421 1 +24 508 95 616 1 +543 51 329 907 1 +586 700 573 493 1 +446 684 67 253 1 +1086 506 1019 109 1 +289 909 5 136 1 +413 652 459 891 1 +608 239 685 566 1 +763 1027 864 646 1 +124 383 569 45 1 +853 1048 542 360 1 +560 875 347 843 1 +1021 1090 687 456 1 +566 303 558 608 1 +27 188 576 152 1 +188 412 576 152 1 +135 284 621 248 1 +1066 265 955 238 1 +587 166 396 378 1 +1148 453 602 688 1 +286 250 484 141 1 +323 111 793 348 1 +667 471 429 374 1 +523 118 329 518 1 +298 595 737 206 1 +317 894 785 899 1 +115 520 114 325 1 +27 188 367 605 1 +763 1145 513 953 1 +770 844 970 1056 1 +429 507 1000 471 1 +27 605 372 576 1 +163 172 1057 942 1 +1116 671 642 512 1 +421 121 635 389 1 +74 371 635 176 1 +626 631 932 541 1 +609 874 628 991 1 +234 202 263 1033 1 +299 541 771 626 1 +736 297 1101 1078 1 +751 1078 270 477 1 +413 459 976 891 1 +878 973 302 420 1 +362 606 742 216 1 +638 447 552 724 1 +954 938 578 417 1 +794 1147 408 652 1 +892 575 388 900 1 +732 259 896 658 1 +604 554 1059 117 1 +299 541 1118 771 1 +624 766 569 168 1 +679 359 961 1040 1 +1016 993 585 977 1 +713 325 352 615 1 +757 920 871 341 1 +245 308 1116 309 1 +671 1025 1116 642 1 +648 294 642 580 1 +497 648 580 216 1 +195 194 196 670 1 +447 679 606 914 1 +735 686 353 148 1 +621 1059 867 1027 1 +223 751 270 375 1 +1045 384 323 755 1 +612 1106 968 935 1 +830 941 720 656 1 +321 963 435 614 1 +78 91 313 686 1 +954 419 974 1031 1 +1095 807 1039 427 1 +45 195 569 168 1 +425 569 383 380 1 +165 177 877 760 1 +228 259 658 219 1 +109 1086 588 999 1 +298 595 73 737 1 +320 478 1133 461 1 +1035 402 640 159 1 +372 403 16 383 1 +909 530 911 532 1 +120 330 918 68 1 +33 464 586 817 1 +759 502 612 852 1 +297 1078 224 270 1 +370 878 1134 756 1 +464 425 380 817 1 +923 321 449 435 1 +679 179 606 34 1 +1137 405 813 397 1 +135 116 248 621 1 +614 535 418 963 1 +530 911 532 952 1 +1016 921 943 584 1 +800 959 392 1061 1 +292 417 1062 404 1 +253 112 67 446 1 +1137 397 443 405 1 +390 273 227 308 1 +769 587 378 426 1 +336 338 835 603 1 +633 1026 746 966 1 +965 797 549 19 1 +832 1123 19 1113 1 +540 682 363 908 1 +434 13 473 885 1 +827 556 157 175 1 +599 677 865 1022 1 +1085 408 1126 510 1 +176 174 371 546 1 +225 299 669 1118 1 +811 797 965 19 1 +383 564 16 425 1 +383 411 564 425 1 +654 368 850 415 1 +29 106 963 130 1 +762 190 678 208 1 +765 844 1056 970 1 +648 294 580 216 1 +383 332 564 411 1 +283 513 953 284 1 +927 414 377 269 1 +731 933 322 662 1 +13 434 999 885 1 +341 871 757 791 1 +646 953 833 864 1 +781 752 841 663 1 +670 694 59 657 1 +685 239 266 566 1 +1062 230 345 669 1 +517 602 251 203 1 +479 746 966 633 1 +679 606 179 447 1 +1001 417 292 404 1 +704 1036 777 930 1 +948 271 820 873 1 +1052 1111 848 1089 1 +384 734 755 1096 1 +363 210 54 682 1 +849 1146 698 1011 1 +105 2 514 920 1 +275 651 1103 727 1 +277 697 782 224 1 +281 199 483 1001 1 +632 103 347 142 1 +705 617 271 820 1 +197 400 1124 402 1 +894 574 1099 1135 1 +199 483 1119 280 1 +99 392 354 522 1 +882 1071 3 871 1 +806 781 1128 42 1 +954 419 1031 902 1 +698 849 1030 472 1 +146 26 664 525 1 +413 377 934 459 1 +567 863 894 574 1 +534 1078 855 736 1 +364 1013 695 972 1 +401 572 719 967 1 +387 79 827 487 1 +991 445 476 940 1 +326 1048 1081 1013 1 +1049 975 1073 937 1 +602 726 444 469 1 +869 1082 1010 819 1 +75 99 410 509 1 +575 192 388 900 1 +64 74 328 635 1 +244 1147 794 652 1 +230 541 345 669 1 +872 438 534 537 1 +575 61 426 778 1 +52 365 144 170 1 +1121 1026 475 1056 1 +577 500 936 906 1 +1058 988 22 568 1 +1022 1098 856 823 1 +828 690 827 861 1 +68 181 667 471 1 +274 610 357 527 1 +771 541 594 626 1 +68 471 918 164 1 +327 393 355 752 1 +482 895 1111 1034 1 +727 511 682 1103 1 +1078 469 782 224 1 +471 429 805 1000 1 +865 599 1009 677 1 +1039 467 425 427 1 +1025 217 648 273 1 +452 762 592 628 1 +68 471 667 918 1 +1050 764 815 1014 1 +917 837 887 805 1 +151 118 355 150 1 +878 302 1088 420 1 +225 1142 771 672 1 +447 881 638 552 1 +999 358 885 844 1 +782 927 1147 244 1 +1142 771 433 593 1 +717 815 23 824 1 +496 88 938 947 1 +809 102 319 335 1 +809 2 102 335 1 +714 420 1004 829 1 +63 262 626 300 1 +231 593 78 361 1 +833 1047 1144 531 1 +585 943 900 562 1 +744 447 37 724 1 +777 815 23 717 1 +1092 455 67 446 1 +513 763 953 646 1 +693 751 534 1075 1 +1006 1067 899 23 1 +497 648 642 580 1 +312 583 156 89 1 +312 947 583 89 1 +619 852 336 612 1 +804 125 773 411 1 +1075 477 751 375 1 +642 1025 1116 217 1 +681 889 913 484 1 +1037 1056 765 17 1 +545 265 237 955 1 +1000 511 540 784 1 +586 464 448 817 1 +664 1086 607 516 1 +69 570 392 1091 1 +75 410 408 794 1 +578 128 702 718 1 +231 593 361 300 1 +419 542 978 811 1 +1107 764 951 842 1 +948 384 734 603 1 +611 1036 945 1121 1 +317 1006 899 1038 1 +103 102 319 809 1 +550 169 367 382 1 +1104 915 1034 930 1 +841 781 898 468 1 +405 1011 988 1058 1 +35 529 125 587 1 +583 613 853 1048 1 +583 326 222 989 1 +620 694 1005 1035 1 +930 23 1006 740 1 +869 510 819 876 1 +397 754 443 1011 1 +1029 601 1018 353 1 +191 43 378 826 1 +960 664 351 480 1 +1053 798 467 493 1 +953 1068 833 864 1 +929 864 481 488 1 +181 507 667 471 1 +712 780 718 434 1 +550 333 25 187 1 +146 525 664 25 1 +667 507 429 471 1 +667 181 182 507 1 +1072 379 807 1095 1 +315 328 758 903 1 +955 252 786 204 1 +243 268 934 242 1 +82 1047 1144 833 1 +1144 1047 621 531 1 +211 1124 1127 295 1 +944 237 10 252 1 +1138 252 237 944 1 +33 643 683 956 1 +646 833 1144 531 1 +125 334 45 773 1 +90 132 953 1068 1 +26 506 1086 109 1 +1093 46 156 52 1 +719 801 1087 654 1 +1045 323 36 808 1 +1137 30 813 403 1 +1147 927 986 652 1 +967 1030 698 691 1 +590 489 761 965 1 +778 193 192 61 1 +509 522 521 149 1 +1040 961 901 912 1 +768 627 774 1004 1 +946 874 916 568 1 +6 258 1044 732 1 +621 76 116 117 1 +610 832 19 479 1 +366 609 22 628 1 +748 803 892 769 1 +495 148 828 690 1 +168 47 400 766 1 +863 688 567 481 1 +786 104 252 791 1 +807 480 351 379 1 +137 730 1074 376 1 +1061 913 49 745 1 +117 116 1059 246 1 +421 64 635 121 1 +962 779 855 736 1 +600 688 863 481 1 +672 1102 1118 925 1 +577 906 915 738 1 +622 504 347 320 1 +58 325 600 531 1 +819 869 876 625 1 +572 967 1072 719 1 +580 821 34 294 1 +504 472 996 870 1 +518 689 328 663 1 +696 807 351 379 1 +811 548 311 902 1 +329 118 51 543 1 +40 384 948 437 1 +540 682 908 784 1 +232 262 1007 233 1 +288 517 251 203 1 +866 665 803 748 1 +1003 180 715 507 1 +917 1004 627 768 1 +207 697 277 297 1 +665 852 612 748 1 +874 851 1090 991 1 +390 618 227 273 1 +180 80 725 207 1 +871 1071 1130 485 1 +527 385 357 712 1 +97 1043 591 11 1 +662 575 1016 921 1 +533 254 739 129 1 +839 340 1123 349 1 +600 1148 688 453 1 +428 90 313 1145 1 +833 1068 481 864 1 +969 450 1145 428 1 +357 712 718 282 1 +656 430 871 791 1 +620 380 624 1005 1 +224 305 782 244 1 +493 700 798 467 1 +16 372 605 462 1 +16 372 425 605 1 +1082 986 1136 819 1 +885 721 995 358 1 +614 676 847 435 1 +815 399 1038 824 1 +770 418 970 844 1 +6 226 732 259 1 +680 654 415 368 1 +152 189 680 7 1 +84 428 495 344 1 +1030 401 967 698 1 +49 1028 775 888 1 +842 768 926 951 1 +1139 213 47 1127 1 +955 237 252 204 1 +775 49 1106 1028 1 +1106 49 331 655 1 +167 831 366 166 1 +232 1055 201 248 1 +584 386 1129 242 1 +565 421 667 918 1 +337 420 714 829 1 +305 269 927 244 1 +659 603 734 889 1 +361 593 201 300 1 +468 395 806 781 1 +86 610 311 789 1 +854 1113 549 497 1 +300 1007 232 262 1 +721 645 582 219 1 +446 919 730 376 1 +954 974 536 1031 1 +370 1134 796 877 1 +678 208 348 762 1 +315 758 162 903 1 +42 689 663 781 1 +508 980 552 97 1 +319 103 809 347 1 +510 919 331 730 1 +432 997 424 186 1 +919 808 681 376 1 +698 1050 717 824 1 +548 966 311 902 1 +702 949 718 385 1 +1076 777 834 1073 1 +393 171 1077 1057 1 +256 632 843 212 1 +805 538 39 837 1 +117 604 501 1059 1 +629 604 1143 117 1 +90 132 1068 84 1 +694 322 563 657 1 +822 957 1080 763 1 +90 1068 428 84 1 +978 761 489 965 1 +200 309 1108 228 1 +859 1129 1141 615 1 +603 323 36 348 1 +950 1042 753 350 1 +988 564 316 769 1 +226 256 896 259 1 +586 448 700 817 1 +605 462 463 1072 1 +598 967 401 698 1 +1116 642 217 512 1 +178 177 760 1002 1 +298 225 925 672 1 +613 601 595 925 1 +636 985 739 533 1 +950 370 1042 350 1 +494 173 387 735 1 +364 663 53 692 1 +637 406 618 854 1 +406 618 318 637 1 +406 11 247 318 1 +234 271 873 264 1 +227 318 618 390 1 +227 318 11 618 1 +1079 802 897 787 1 +543 1015 961 1012 1 +961 359 1012 1040 1 +431 763 864 1080 1 +833 747 1068 1054 1 +496 86 311 789 1 +1006 23 930 738 1 +15 443 122 1137 1 +667 429 565 374 1 +823 407 1067 571 1 +199 1119 1064 229 1 +149 522 857 526 1 +4 2 103 1065 1 +881 1100 1041 14 1 +353 1018 1029 450 1 +807 480 379 1072 1 +406 591 1043 11 1 +362 591 216 273 1 +1051 318 964 637 1 +306 678 20 208 1 +259 256 896 219 1 +30 813 403 529 1 +690 53 1009 1029 1 +545 1138 237 987 1 +495 693 1075 344 1 +652 269 459 205 1 +787 696 923 596 1 +794 410 408 1147 1 +617 711 348 338 1 +618 273 497 591 1 +96 97 11 1043 1 +224 305 469 782 1 +948 603 659 836 1 +480 664 351 1024 1 +50 557 158 838 1 +349 825 214 255 1 +557 36 585 838 1 +809 335 319 3 1 +104 909 2 341 1 +550 188 367 169 1 +654 801 661 189 1 +99 98 959 800 1 +450 313 433 1145 1 +391 867 1079 72 1 +366 831 628 592 1 +732 896 461 658 1 +583 1048 1081 326 1 +1056 1031 770 17 1 +970 792 475 886 1 +577 486 983 898 1 +317 894 683 643 1 +895 824 1053 598 1 +129 254 739 289 1 +152 189 412 680 1 +152 412 415 680 1 +357 385 718 712 1 +142 4 810 931 1 +335 911 530 904 1 +335 491 911 904 1 +3 716 1017 649 1 +1028 984 869 666 1 +781 1109 1098 856 1 +370 878 796 1134 1 +667 429 381 565 1 +1134 275 796 653 1 +402 467 400 696 1 +479 964 845 886 1 +960 664 480 333 1 +798 700 1005 467 1 +620 1005 624 1035 1 +685 651 608 840 1 +542 841 811 884 1 +298 710 925 225 1 +182 635 668 176 1 +646 953 1144 833 1 +618 273 591 11 1 +438 668 371 176 1 +37 447 744 1002 1 +74 174 371 176 1 +74 328 758 315 1 +942 172 1013 326 1 +942 172 326 73 1 +328 421 635 381 1 +442 998 1073 842 1 +921 1016 788 575 1 +962 855 1082 981 1 +1002 447 950 359 1 +1083 860 1067 868 1 +486 395 983 898 1 +842 1014 998 764 1 +637 406 579 491 1 +735 487 173 387 1 +638 497 216 591 1 +362 638 216 591 1 +998 1038 23 815 1 +638 497 606 216 1 +362 638 606 216 1 +362 638 160 606 1 +638 447 724 606 1 +934 470 413 859 1 +781 856 1098 395 1 +680 189 412 654 1 +765 824 740 598 1 +617 678 705 437 1 +241 81 414 305 1 +585 557 388 892 1 +240 453 1141 749 1 +93 92 344 85 1 +621 1055 646 1027 1 +353 495 690 148 1 +1110 1019 999 1086 1 +96 980 97 1043 1 +424 754 849 996 1 +680 189 654 7 1 +6 226 258 732 1 +836 18 1021 982 1 +42 1015 329 565 1 +382 480 807 605 1 +968 951 18 764 1 +330 68 121 389 1 +666 1022 856 823 1 +962 981 986 1147 1 +512 217 245 255 1 +322 563 713 448 1 +499 645 296 582 1 +629 58 713 604 1 +22 396 452 378 1 +503 756 511 674 1 +1142 433 313 1145 1 +499 645 212 296 1 +499 560 212 645 1 +614 17 1024 516 1 +873 734 1033 659 1 +68 181 182 667 1 +772 715 423 890 1 +996 369 634 754 1 +593 626 816 300 1 +952 96 1043 980 1 +1000 784 540 908 1 +226 875 278 198 1 +915 740 1104 394 1 +872 668 779 438 1 +133 730 539 62 1 +888 538 1028 775 1 +23 704 777 930 1 +907 503 374 674 1 +168 624 766 400 1 +270 469 1078 224 1 +467 1039 425 380 1 +770 475 792 633 1 +960 333 480 1139 1 +548 938 954 417 1 +450 313 1145 428 1 +808 919 1115 759 1 +924 1080 567 868 1 +563 604 1143 629 1 +1031 847 776 974 1 +491 875 1020 1051 1 +636 862 398 812 1 +801 525 661 189 1 +954 578 404 417 1 +1088 1132 608 829 1 +98 290 1085 133 1 +625 899 984 935 1 +399 785 1014 1038 1 +662 921 1016 584 1 +873 734 659 948 1 +475 945 845 746 1 +773 334 45 383 1 +899 785 1038 935 1 +570 98 99 800 1 +767 659 835 18 1 +696 787 1125 814 1 +773 587 332 411 1 +997 799 424 186 1 +1024 676 351 379 1 +963 41 1119 483 1 +873 271 820 236 1 +431 1027 743 864 1 +1074 127 1096 286 1 +653 275 796 48 1 +878 420 350 145 1 +183 653 48 939 1 +183 979 653 939 1 +1079 1052 880 957 1 +275 651 685 1103 1 +1087 661 155 218 1 +486 1098 983 395 1 +1089 573 743 897 1 +840 1088 608 829 1 +529 813 332 123 1 +1030 1011 698 691 1 +737 73 641 595 1 +778 788 575 61 1 +515 597 713 992 1 +1007 233 630 1079 1 +962 981 1147 410 1 +1095 379 807 1053 1 +507 429 373 667 1 +324 486 53 818 1 +832 512 479 610 1 +371 328 689 903 1 +667 429 373 381 1 +630 233 787 1079 1 +174 79 546 175 1 +956 1094 1016 892 1 +452 592 366 628 1 +1005 604 501 563 1 +571 998 842 935 1 +450 65 1029 353 1 +968 842 951 764 1 +678 208 705 437 1 +529 30 334 403 1 +672 433 1142 771 1 +589 423 779 1022 1 +615 515 713 992 1 +372 27 367 605 1 +455 386 943 304 1 +654 850 368 499 1 +892 852 977 36 1 +581 728 703 465 1 +129 1063 5 289 1 +131 833 82 288 1 +432 424 397 366 1 +210 266 54 682 1 +744 950 447 552 1 +57 110 519 1045 1 +924 586 573 493 1 +874 619 338 456 1 +65 693 488 1131 1 +329 907 918 565 1 +513 646 284 1055 1 +65 693 495 488 1 +20 831 628 733 1 +654 368 7 499 1 +479 886 475 633 1 +658 886 1084 721 1 +859 56 615 1148 1 +891 413 510 919 1 +617 705 271 437 1 +454 476 220 687 1 +690 53 487 677 1 +557 866 892 36 1 +757 485 871 920 1 +805 511 1000 784 1 +622 212 142 634 1 +1068 488 747 481 1 +747 477 251 602 1 +341 2 920 514 1 +722 687 733 705 1 +411 670 196 426 1 +739 337 532 905 1 +776 847 44 974 1 +875 319 904 491 1 +771 541 1118 594 1 +1062 858 261 925 1 +90 283 953 132 1 +992 386 615 515 1 +427 691 1095 1053 1 +953 1144 82 284 1 +132 953 82 284 1 +1062 708 853 925 1 +428 90 1145 953 1 +230 541 669 299 1 +151 1112 1140 355 1 +427 1095 425 1039 1 +1053 1095 379 598 1 +1095 605 425 1039 1 +1062 925 261 669 1 +600 615 863 1148 1 +605 367 1039 382 1 +799 424 940 445 1 +765 611 478 1133 1 +1095 691 967 598 1 +885 792 970 1084 1 +891 457 446 205 1 +429 507 373 772 1 +195 59 670 620 1 +195 59 194 670 1 +727 682 994 840 1 +64 330 121 421 1 +150 118 355 543 1 +80 725 297 1101 1 +59 194 670 657 1 +918 330 329 421 1 +341 335 514 871 1 +600 1148 863 688 1 +617 348 678 437 1 +905 739 941 656 1 +845 945 1020 1076 1 +223 872 1101 537 1 +1101 751 270 223 1 +12 533 980 532 1 +102 319 335 278 1 +95 616 1097 420 1 +1097 616 552 350 1 +432 424 366 831 1 +95 94 420 1097 1 +535 846 614 780 1 +1118 1102 708 925 1 +581 806 856 416 1 +617 456 836 820 1 +1137 813 405 403 1 +852 665 866 748 1 +521 715 890 725 1 +843 632 347 622 1 +347 320 649 560 1 +805 887 784 837 1 +1011 451 988 1146 1 +133 730 62 291 1 +636 739 941 337 1 +814 700 1005 798 1 +616 508 1097 552 1 +337 829 636 1132 1 +1111 895 1104 1034 1 +57 127 376 1074 1 +949 770 614 780 1 +1010 56 574 984 1 +1052 1111 1089 802 1 +49 908 745 888 1 +438 668 677 371 1 +608 862 1132 985 1 +852 759 808 1115 1 +121 74 64 635 1 +1002 177 877 370 1 +888 837 538 805 1 +921 61 933 575 1 +149 526 857 70 1 +432 185 397 997 1 +568 1146 783 1050 1 +869 1010 547 666 1 +416 1015 674 728 1 +395 761 581 704 1 +166 190 20 592 1 +26 790 155 1086 1 +726 981 444 469 1 +781 752 42 961 1 +1141 1148 470 859 1 +688 863 567 574 1 +419 500 542 853 1 +641 972 595 73 1 +961 1070 505 912 1 +656 871 341 791 1 +449 213 750 293 1 +758 174 162 173 1 +758 487 173 903 1 +261 230 1062 669 1 +151 170 34 1140 1 +480 647 379 1072 1 +328 64 635 421 1 +583 1081 156 326 1 +1028 49 1106 655 1 +529 123 332 587 1 +720 656 882 830 1 +959 408 410 893 1 +4 514 1065 810 1 +869 510 876 331 1 +924 482 1034 868 1 +450 65 353 313 1 +638 447 606 914 1 +575 1016 788 900 1 +763 969 1145 953 1 +1108 527 712 479 1 +451 399 1146 824 1 +863 992 713 910 1 +499 560 645 721 1 +178 177 165 760 1 +878 973 420 145 1 +1020 875 461 732 1 +84 723 1068 139 1 +128 357 702 718 1 +531 833 864 646 1 +508 533 980 12 1 +950 544 359 881 1 +761 1049 581 1073 1 +731 741 662 209 1 +717 824 23 740 1 +604 554 897 1059 1 +529 403 773 332 1 +935 785 612 625 1 +516 844 647 1110 1 +722 687 705 236 1 +396 988 316 22 1 +888 908 745 784 1 +621 520 117 554 1 +1028 984 571 935 1 +1052 673 880 957 1 +996 851 445 1071 1 +173 641 903 1069 1 +550 382 367 605 1 +928 785 399 971 1 +998 777 1073 842 1 +696 379 351 923 1 +739 636 941 656 1 +1018 353 601 639 1 +870 716 717 553 1 +421 381 328 518 1 +546 827 487 371 1 +90 953 428 1068 1 +689 53 677 371 1 +589 689 677 371 1 +796 973 878 145 1 +689 668 371 589 1 +748 785 928 643 1 +833 747 288 517 1 +635 689 328 381 1 +635 668 689 381 1 +635 371 689 668 1 +289 254 739 786 1 +550 187 47 1139 1 +664 801 25 525 1 +650 820 836 1021 1 +976 934 459 413 1 +583 925 989 222 1 +852 866 892 748 1 +1020 875 732 1051 1 +546 79 487 827 1 +644 1093 312 884 1 +907 918 471 164 1 +536 1064 435 847 1 +536 345 974 404 1 +890 893 962 775 1 +694 707 1035 59 1 +716 1008 717 553 1 +176 546 371 438 1 +284 201 1055 248 1 +317 868 899 1006 1 +482 868 317 1006 1 +149 180 521 207 1 +620 464 1005 694 1 +930 1036 777 740 1 +895 482 317 1006 1 +587 529 125 773 1 +75 290 794 408 1 +727 1134 756 653 1 +1071 882 553 430 1 +1131 65 1009 818 1 +962 779 666 865 1 +486 339 324 692 1 +75 410 794 277 1 +964 9 479 845 1 +89 88 947 417 1 +341 656 905 911 1 +605 382 1039 807 1 +562 455 943 304 1 +81 268 377 269 1 +973 95 420 145 1 +503 653 511 756 1 +892 866 852 36 1 +909 791 905 341 1 +854 591 1043 406 1 +780 633 712 385 1 +883 631 44 957 1 +235 436 409 566 1 +672 639 206 257 1 +349 365 1123 839 1 +740 1104 1056 1037 1 +605 480 807 1072 1 +864 1131 488 929 1 +936 419 915 776 1 +128 789 702 357 1 +807 467 1039 427 1 +365 884 1077 52 1 +190 762 452 557 1 +924 1089 482 493 1 +663 752 841 695 1 +456 991 687 733 1 +86 274 357 128 1 +86 357 789 128 1 +482 868 924 317 1 +832 311 1123 349 1 +1095 462 605 1072 1 +803 988 316 769 1 +1109 1098 486 781 1 +493 924 317 482 1 +981 855 1082 444 1 +49 959 893 1126 1 +359 544 760 543 1 +940 799 476 831 1 +339 692 898 695 1 +205 794 290 891 1 +656 830 905 911 1 +909 341 905 911 1 +461 896 560 645 1 +887 511 682 727 1 +341 2 514 335 1 +1 632 347 843 1 +335 809 514 3 1 +946 982 764 619 1 +345 44 1118 594 1 +691 451 824 971 1 +75 794 244 277 1 +982 18 764 835 1 +1116 964 390 671 1 +276 295 233 787 1 +440 602 726 444 1 +207 509 521 149 1 +176 668 371 635 1 +770 418 792 970 1 +430 1090 1021 982 1 +921 662 209 584 1 +389 381 373 668 1 +760 177 877 1002 1 +1100 1070 1012 1041 1 +655 887 784 994 1 +715 668 779 872 1 +637 618 390 9 1 +455 934 243 457 1 +421 667 389 381 1 +10 757 454 301 1 +58 713 910 600 1 +28 349 311 610 1 +765 698 824 598 1 +994 566 409 922 1 +710 261 222 925 1 +378 826 388 575 1 +464 448 597 586 1 +1113 1123 19 549 1 +553 1050 1107 717 1 +180 521 207 725 1 +765 824 611 740 1 +663 695 692 364 1 +377 269 652 927 1 +464 586 597 33 1 +719 654 1087 995 1 +713 586 448 573 1 +1053 817 971 317 1 +794 244 290 75 1 +1046 211 1120 814 1 +713 325 615 600 1 +58 325 713 600 1 +80 872 1101 223 1 +771 594 883 626 1 +537 751 534 1101 1 +1139 729 1124 696 1 +818 450 1018 822 1 +941 714 829 337 1 +327 42 518 663 1 +598 401 765 698 1 +52 1081 1093 884 1 +787 630 880 923 1 +1093 365 144 52 1 +811 505 884 841 1 +311 349 832 610 1 +456 982 1021 1090 1 +606 179 724 742 1 +991 940 476 733 1 +703 571 39 856 1 +674 1004 465 753 1 +1089 802 1079 1052 1 +140 38 88 578 1 +803 928 988 769 1 +405 1011 16 988 1 +418 1110 999 844 1 +1103 651 840 727 1 +887 756 1004 674 1 +1143 604 501 117 1 +538 39 666 423 1 +128 357 718 282 1 +1036 777 1073 704 1 +798 696 596 379 1 +412 189 801 654 1 +631 1064 932 541 1 +206 686 353 735 1 +1068 344 139 747 1 +890 725 779 736 1 +432 397 424 997 1 +38 128 578 32 1 +182 180 1003 507 1 +1050 851 1146 553 1 +535 846 780 718 1 +639 353 206 686 1 +463 801 550 480 1 +1049 14 579 854 1 +940 476 733 831 1 +43 190 452 557 1 +43 190 557 143 1 +430 1090 982 946 1 +470 1141 453 1148 1 +842 998 777 1107 1 +876 919 331 510 1 +730 331 681 919 1 +721 310 473 219 1 +461 721 658 219 1 +577 898 983 978 1 +352 147 115 629 1 +577 983 738 978 1 +77 474 352 551 1 +698 1146 870 553 1 +1146 851 870 553 1 +801 664 333 480 1 +188 801 412 189 1 +658 721 1084 473 1 +581 1060 1073 975 1 +738 860 823 983 1 +1058 1011 988 1146 1 +107 664 490 146 1 +915 1026 740 394 1 +585 557 838 158 1 +4 2 1065 514 1 +948 617 836 820 1 +906 500 818 577 1 +989 222 925 298 1 +1023 14 579 937 1 +791 104 757 341 1 +284 621 1144 135 1 +424 754 997 397 1 +1010 1082 1117 56 1 +596 1052 848 847 1 +529 334 125 773 1 +621 284 1055 248 1 +817 380 1005 467 1 +1058 1146 988 568 1 +915 394 1104 1031 1 +1104 394 1056 1031 1 +399 1050 1146 824 1 +853 339 1048 613 1 +624 1005 467 402 1 +923 709 880 435 1 +350 878 145 370 1 +792 712 633 1084 1 +832 642 512 349 1 +993 386 976 879 1 +485 991 687 1090 1 +1029 53 1009 818 1 +345 44 708 1118 1 +954 1031 949 966 1 +200 512 527 1116 1 +63 932 626 262 1 +539 681 62 730 1 +320 504 472 369 1 +136 126 530 5 1 +619 968 1014 612 1 +561 455 943 562 1 +504 369 996 472 1 +472 478 401 698 1 +672 1102 1018 433 1 +507 667 373 182 1 +98 290 75 408 1 +782 697 410 736 1 +344 477 440 693 1 +1011 451 1146 691 1 +712 434 249 1084 1 +1106 869 625 876 1 +782 305 469 927 1 +1033 202 436 250 1 +746 590 1049 549 1 +928 988 451 783 1 +772 890 423 538 1 +946 1107 553 1050 1 +865 693 534 677 1 +444 693 865 440 1 +495 65 861 693 1 +865 1009 693 677 1 +798 1005 402 467 1 +162 173 73 641 1 +1085 408 510 891 1 +782 697 736 224 1 +1100 761 806 468 1 +298 925 595 672 1 +383 773 403 332 1 +300 626 816 1007 1 +98 133 1085 539 1 +881 1100 728 1012 1 +139 92 251 344 1 +535 614 846 963 1 +705 820 271 236 1 +646 531 621 1027 1 +1001 199 441 292 1 +150 1114 543 679 1 +604 58 713 573 1 +483 963 846 435 1 +882 871 656 430 1 +80 1101 297 223 1 +971 399 451 824 1 +539 1085 1126 730 1 +234 384 734 948 1 +875 896 461 732 1 +559 518 328 663 1 +851 874 946 568 1 +711 348 762 628 1 +687 820 705 236 1 +993 1016 386 1094 1 +1083 1009 1131 693 1 +480 382 807 1139 1 +400 47 382 766 1 +1035 563 501 1143 1 +394 633 770 949 1 +889 745 922 655 1 +671 642 1113 555 1 +288 517 747 251 1 +606 724 160 742 1 +499 654 1087 661 1 +481 58 531 743 1 +86 274 610 357 1 +359 544 1012 881 1 +86 128 938 38 1 +1095 462 1072 967 1 +478 765 970 995 1 +637 1076 1049 845 1 +1056 17 844 765 1 +776 974 936 419 1 +530 532 5 952 1 +936 500 419 974 1 +638 724 552 160 1 +156 312 1093 1081 1 +527 1116 479 1108 1 +416 728 917 703 1 +341 2 104 920 1 +14 881 638 1041 1 +411 464 660 769 1 +60 171 393 163 1 +451 564 16 988 1 +839 1112 505 901 1 +599 818 1032 1009 1 +1146 851 849 870 1 +430 706 871 791 1 +143 190 762 208 1 +758 173 162 903 1 +608 238 985 422 1 +496 38 86 938 1 +767 659 18 650 1 +166 366 396 452 1 +940 424 1058 851 1 +1050 568 1146 851 1 +290 408 1085 891 1 +775 49 331 1106 1 +845 1076 1049 746 1 +303 31 558 545 1 +584 921 943 307 1 +430 982 460 946 1 +701 259 732 658 1 +1072 463 801 412 1 +288 747 139 251 1 +303 31 545 265 1 +477 251 344 747 1 +618 591 406 11 1 +339 486 577 898 1 +1011 1058 849 1146 1 +600 749 615 1141 1 +600 325 615 749 1 +325 749 352 615 1 +325 77 352 749 1 +517 688 602 453 1 +446 919 376 1092 1 +690 1029 65 353 1 +749 77 551 272 1 +485 991 476 687 1 +656 460 398 941 1 +1146 1058 851 568 1 +23 899 1038 998 1 +322 731 662 352 1 +861 537 157 1075 1 +551 749 272 515 1 +352 615 749 515 1 +577 1032 738 860 1 +958 901 1040 961 1 +222 710 925 298 1 +1141 615 1148 859 1 +608 774 829 862 1 +545 264 873 987 1 +928 956 748 643 1 +33 769 928 956 1 +137 57 112 376 1 +613 1048 989 972 1 +129 532 5 1063 1 +383 367 124 569 1 +1066 238 955 985 1 +99 69 392 522 1 +480 550 382 1139 1 +1066 955 862 985 1 +1136 377 652 927 1 +450 65 969 818 1 +857 526 1000 70 1 +961 1012 806 468 1 +578 128 938 702 1 +874 609 851 991 1 +498 960 449 213 1 +997 8 996 799 1 +937 941 720 830 1 +956 683 597 992 1 +443 1011 356 405 1 +1105 472 850 369 1 +827 537 157 861 1 +570 66 98 800 1 +15 813 123 167 1 +922 659 436 1033 1 +569 620 804 380 1 +190 20 592 678 1 +664 516 647 790 1 +677 693 534 861 1 +565 907 374 674 1 +987 264 873 236 1 +568 609 851 874 1 +417 548 360 853 1 +1085 730 291 891 1 +897 554 1027 1059 1 +819 510 413 876 1 +601 641 324 613 1 +927 305 469 414 1 +1065 2 103 809 1 +107 607 106 41 1 +1045 110 384 127 1 +995 401 478 765 1 +1113 642 1123 497 1 +558 1066 862 608 1 +493 802 1111 798 1 +707 563 1035 1143 1 +190 762 557 143 1 +999 358 588 885 1 +865 751 534 693 1 +291 730 1074 137 1 +903 663 53 364 1 +917 887 837 627 1 +542 853 548 419 1 +50 519 838 113 1 +376 1096 681 1074 1 +451 928 783 399 1 +993 386 455 976 1 +760 877 503 674 1 +1069 641 53 324 1 +587 193 826 426 1 +395 704 581 442 1 +560 843 212 645 1 +1087 499 218 582 1 +826 193 192 778 1 +970 995 885 721 1 +827 175 537 438 1 +781 1098 486 395 1 +536 345 44 974 1 +387 735 487 690 1 +665 852 619 612 1 +338 852 619 665 1 +626 932 631 1007 1 +837 538 39 666 1 +950 881 753 544 1 +9 555 390 671 1 +823 1022 860 407 1 +407 1022 860 1083 1 +583 1048 989 613 1 +648 255 642 294 1 +372 462 576 605 1 +713 586 910 683 1 +41 490 321 449 1 +890 715 423 779 1 +854 579 1023 14 1 +15 1137 813 397 1 +924 868 894 317 1 +1074 286 681 62 1 +926 768 774 951 1 +743 573 554 897 1 +587 529 773 332 1 +804 773 383 411 1 +557 452 388 892 1 +769 803 892 378 1 +557 892 585 36 1 +122 30 528 1137 1 +918 120 68 164 1 +830 905 941 656 1 +948 836 873 820 1 +722 687 220 733 1 +852 502 612 1094 1 +315 663 364 559 1 +383 804 411 380 1 +411 804 464 380 1 +655 837 784 887 1 +478 995 970 721 1 +904 406 952 247 1 +1097 1043 337 1023 1 +946 764 1107 1050 1 +269 268 934 243 1 +558 466 18 774 1 +526 979 183 161 1 +194 933 670 731 1 +311 832 19 610 1 +1035 1005 624 402 1 +722 733 306 705 1 +1097 980 1043 552 1 +97 980 552 1043 1 +68 121 389 182 1 +508 980 1097 552 1 +726 470 602 1148 1 +955 252 791 786 1 +433 822 1145 883 1 +1094 1016 992 956 1 +769 426 575 660 1 +5 532 138 952 1 +823 1067 442 571 1 +1145 822 763 883 1 +321 607 1024 490 1 +9 1113 549 854 1 +333 146 25 187 1 +375 537 1075 157 1 +98 408 75 959 1 +149 69 522 526 1 +503 877 756 674 1 +1086 506 607 1019 1 +354 392 959 888 1 +607 321 41 490 1 +480 664 647 801 1 +65 1009 690 861 1 +103 4 1065 142 1 +987 873 820 236 1 +44 500 822 906 1 +606 679 1040 914 1 +719 654 995 1105 1 +598 572 765 401 1 +1038 1014 815 998 1 +106 41 483 280 1 +765 740 611 1121 1 +312 360 884 1048 1 +117 1059 501 246 1 +452 366 396 22 1 +314 559 364 942 1 +890 715 779 725 1 +909 335 911 530 1 +665 619 874 916 1 +1027 867 1079 897 1 +760 544 1015 543 1 +565 1015 674 416 1 +723 132 953 82 1 +928 748 783 399 1 +837 571 1028 666 1 +316 332 564 988 1 +897 1046 814 501 1 +516 664 1086 790 1 +825 144 349 214 1 +1079 233 787 276 1 +779 534 736 725 1 +97 1043 638 591 1 +1042 756 674 1004 1 +779 677 534 438 1 +668 677 779 438 1 +277 697 410 782 1 +472 401 1105 850 1 +853 404 548 974 1 +421 389 635 381 1 +291 891 446 205 1 +916 764 1050 1014 1 +362 97 591 11 1 +928 399 451 971 1 +1065 504 347 142 1 +169 47 766 382 1 +319 809 3 347 1 +214 349 839 144 1 +798 696 379 807 1 +70 180 507 857 1 +885 13 473 310 1 +810 514 1130 485 1 +555 273 390 1025 1 +687 476 220 733 1 +877 756 1134 653 1 +536 974 954 404 1 +349 311 1123 365 1 +404 974 853 708 1 +641 339 324 613 1 +776 974 44 936 1 +569 383 804 45 1 +506 29 963 1019 1 +383 569 804 380 1 +726 819 1082 1136 1 +713 615 863 600 1 +727 840 1103 682 1 +637 1076 579 1049 1 +581 856 395 442 1 +934 859 386 242 1 +1145 883 763 816 1 +960 146 664 333 1 +414 470 726 1136 1 +948 836 659 873 1 +354 410 736 893 1 +963 614 846 435 1 +513 1145 593 283 1 +54 235 409 266 1 +133 1085 539 730 1 +1019 999 1086 109 1 +962 890 736 893 1 +354 959 410 893 1 +535 780 434 718 1 +339 641 692 972 1 +858 925 222 261 1 +641 972 339 613 1 +276 1120 295 787 1 +989 972 595 613 1 +613 641 595 601 1 +830 911 882 1017 1 +994 346 745 922 1 +544 753 674 728 1 +145 24 616 744 1 +408 986 510 652 1 +677 487 690 827 1 +961 468 505 1070 1 +613 339 1048 972 1 +613 925 708 1102 1 +910 586 573 924 1 +404 974 708 345 1 +71 1143 159 117 1 +1001 199 1064 441 1 +853 925 708 613 1 +706 1090 687 1021 1 +1035 1005 501 563 1 +898 781 841 663 1 +614 607 418 516 1 +1049 14 975 937 1 +808 502 759 852 1 +601 353 206 639 1 +696 379 923 596 1 +182 635 389 668 1 +822 883 44 957 1 +68 182 389 667 1 +639 1142 313 78 1 +761 1049 1073 590 1 +365 839 144 170 1 +17 379 647 572 1 +752 695 663 364 1 +341 911 871 656 1 +182 121 389 635 1 +1056 394 770 1031 1 +577 860 738 983 1 +808 323 36 603 1 +391 1120 787 814 1 +1123 912 549 497 1 +500 339 818 577 1 +348 111 793 143 1 +267 203 602 453 1 +453 600 1141 749 1 +908 682 363 54 1 +906 44 500 936 1 +732 964 1044 701 1 +35 191 166 587 1 +336 338 603 852 1 +808 323 603 755 1 +886 1020 1133 461 1 +619 338 336 852 1 +435 846 536 847 1 +587 191 166 378 1 +603 755 734 889 1 +619 338 835 336 1 +6 258 227 1044 1 +278 904 530 279 1 +689 589 1109 1128 1 +904 1122 911 952 1 +322 660 597 662 1 +322 933 660 662 1 +802 814 897 787 1 +723 132 1068 953 1 +445 996 810 799 1 +369 754 368 184 1 +151 1140 34 958 1 +634 810 504 996 1 +543 961 1015 42 1 +479 746 633 475 1 +1109 53 599 677 1 +385 527 610 479 1 +463 480 605 1072 1 +1093 156 1081 52 1 +1053 379 1111 895 1 +1132 862 636 985 1 +285 1096 286 202 1 +315 559 364 314 1 +1026 902 966 394 1 +351 960 807 696 1 +433 816 1145 593 1 +869 547 1010 1082 1 +662 992 597 515 1 +185 8 997 186 1 +911 830 1122 491 1 +479 845 746 475 1 +683 597 713 586 1 +930 915 489 740 1 +166 592 366 452 1 +707 1035 640 159 1 +913 889 745 484 1 +552 1097 1023 1043 1 +343 767 926 655 1 +1146 451 783 399 1 +730 919 446 891 1 +845 945 1076 746 1 +563 448 322 694 1 +730 510 919 891 1 +436 922 250 409 1 +655 837 887 627 1 +964 318 390 637 1 +1145 816 513 593 1 +1045 1096 384 755 1 +599 53 818 1009 1 +18 659 835 836 1 +842 1073 1060 834 1 +783 916 1050 399 1 +417 360 583 853 1 +1095 16 425 605 1 +429 507 772 1000 1 +463 188 605 550 1 +452 22 866 711 1 +188 463 605 576 1 +812 656 739 791 1 +195 620 569 168 1 +903 641 53 1069 1 +1098 856 823 395 1 +804 620 464 380 1 +670 620 464 804 1 +195 620 804 569 1 +195 620 670 804 1 +934 859 413 976 1 +234 40 948 271 1 +1040 912 497 1041 1 +155 1087 218 358 1 +1050 1014 815 399 1 +805 538 423 39 1 +772 538 423 805 1 +429 805 423 39 1 +429 772 423 805 1 +335 2 514 809 1 +103 2 102 809 1 +596 847 848 776 1 +697 410 736 521 1 +847 44 848 776 1 +1142 593 433 1145 1 +1142 593 1145 78 1 +648 216 497 273 1 +1112 170 1140 901 1 +958 901 355 1140 1 +900 192 158 221 1 +142 504 347 622 1 +728 581 703 416 1 +587 332 316 396 1 +369 212 368 499 1 +211 402 1046 159 1 +626 883 816 1007 1 +519 112 1092 113 1 +646 284 1055 621 1 +411 464 670 660 1 +481 600 688 517 1 +629 520 115 325 1 +370 756 1134 877 1 +712 434 134 249 1 +791 656 905 341 1 +812 398 774 862 1 +862 636 398 829 1 +4 810 154 105 1 +4 514 810 105 1 +711 338 874 866 1 +1133 716 1020 1008 1 +810 799 154 476 1 +445 799 810 476 1 +142 810 634 8 1 +142 931 810 8 1 +142 810 504 634 1 +919 808 376 1092 1 +904 406 1122 952 1 +555 648 497 273 1 +534 725 1101 736 1 +646 531 1144 621 1 +82 1047 135 1144 1 +944 301 687 757 1 +119 315 162 314 1 +692 53 486 663 1 +924 1089 1034 482 1 +688 600 453 517 1 +188 25 550 801 1 +696 814 402 798 1 +802 814 798 700 1 +802 696 798 814 1 +1141 1129 749 615 1 +42 416 565 1128 1 +90 78 1145 283 1 +631 932 880 1007 1 +1124 729 295 1125 1 +696 787 814 802 1 +775 49 1126 331 1 +1126 49 913 331 1 +958 1040 34 679 1 +696 1125 1124 814 1 +696 729 1124 1125 1 +542 898 841 695 1 +234 40 285 384 1 +1061 1126 913 539 1 +787 1120 1125 814 1 +680 412 415 654 1 +1028 538 837 666 1 +350 950 744 552 1 +521 410 354 509 1 +1139 333 550 187 1 +232 1079 1007 1055 1 +1100 761 549 1049 1 +771 816 593 626 1 +1053 817 427 971 1 +771 433 593 816 1 +1091 1000 526 979 1 +1114 359 760 543 1 +152 7 680 368 1 +339 1102 818 324 1 +898 663 695 692 1 +842 935 998 1014 1 +276 1120 787 391 1 +418 1019 434 999 1 +506 108 1019 109 1 +194 61 426 933 1 +1024 676 17 614 1 +478 320 560 461 1 +321 1119 435 963 1 +860 738 1067 868 1 +338 603 617 836 1 +578 846 954 536 1 +720 656 460 882 1 +805 471 1000 511 1 +859 879 615 56 1 +105 485 454 920 1 +1024 516 647 664 1 +854 406 579 637 1 +768 1004 398 439 1 +288 747 1054 139 1 +514 2 1065 809 1 +836 619 835 982 1 +194 933 426 670 1 +374 429 805 471 1 +301 687 236 820 1 +969 1145 822 763 1 +903 689 371 53 1 +338 619 836 456 1 +958 1140 34 901 1 +1072 801 463 480 1 +614 949 846 1031 1 +819 986 510 869 1 +822 763 883 957 1 +1145 816 763 513 1 +630 932 880 709 1 +488 481 929 440 1 +790 1087 155 358 1 +746 1049 9 549 1 +1100 881 975 14 1 +896 219 256 645 1 +791 944 757 252 1 +456 619 982 874 1 +1091 979 161 540 1 +339 692 486 898 1 +677 371 827 438 1 +677 371 487 827 1 +828 556 387 148 1 +690 387 828 827 1 +534 677 537 438 1 +699 24 744 724 1 +1007 883 957 631 1 +617 711 338 456 1 +690 387 827 487 1 +828 387 556 827 1 +864 1068 488 428 1 +274 512 527 200 1 +424 186 799 831 1 +556 827 157 828 1 +1011 16 451 691 1 +611 1008 717 716 1 +546 79 827 175 1 +174 546 487 371 1 +174 79 487 546 1 +1113 671 479 832 1 +746 9 479 1113 1 +811 505 841 468 1 +488 440 344 747 1 +812 985 862 955 1 +440 444 477 602 1 +1121 1056 475 970 1 +276 211 295 1120 1 +671 9 479 964 1 +671 1025 390 1116 1 +418 885 792 970 1 +629 76 520 117 1 +752 841 884 505 1 +1083 1067 574 868 1 +1022 1098 860 599 1 +344 440 477 747 1 +432 186 424 831 1 +672 601 206 639 1 +608 1066 862 985 1 +985 791 739 786 1 +597 322 713 448 1 +1132 636 337 533 1 +994 346 409 682 1 +1146 451 824 691 1 +1063 909 5 289 1 +1086 790 155 358 1 +770 792 780 633 1 +411 660 670 426 1 +197 400 47 1124 1 +458 1124 1127 211 1 +105 476 154 454 1 +4 810 931 154 1 +338 835 603 836 1 +932 229 709 262 1 +101 100 908 54 1 +1122 337 532 980 1 +696 402 1124 400 1 +286 484 62 141 1 +321 41 449 1119 1 +904 319 278 335 1 +909 532 911 905 1 +904 406 491 1122 1 +842 571 442 998 1 +797 365 505 1123 1 +324 641 53 692 1 +818 822 1032 969 1 +531 554 621 1027 1 +843 256 212 645 1 +1142 1145 313 78 1 +625 935 1106 612 1 +1067 899 998 935 1 +123 332 587 166 1 +851 991 485 1090 1 +1077 1081 52 884 1 +277 521 697 207 1 +574 1135 894 899 1 +954 789 966 702 1 +320 504 870 472 1 +895 379 1111 1037 1 +358 721 995 582 1 +26 1086 155 109 1 +90 78 313 1145 1 +782 305 927 244 1 +613 972 595 641 1 +689 1109 781 1128 1 +672 433 639 1142 1 +90 1145 953 283 1 +450 433 822 1145 1 +660 575 662 933 1 +700 501 897 814 1 +450 1145 822 969 1 +364 695 692 972 1 +349 644 365 144 1 +672 1018 639 433 1 +672 639 1018 601 1 +282 712 134 249 1 +564 16 425 427 1 +358 721 582 310 1 +30 403 372 334 1 +1084 721 885 473 1 +723 953 1068 833 1 +1064 483 536 435 1 +589 1109 677 689 1 +1095 967 572 598 1 +585 977 36 892 1 +624 467 766 400 1 +237 987 944 301 1 +427 16 425 1095 1 +1148 615 863 56 1 +970 1084 886 721 1 +683 586 910 894 1 +990 833 131 288 1 +1007 1079 816 1055 1 +583 925 222 858 1 +19 1113 479 832 1 +1002 744 37 699 1 +1099 863 992 615 1 +737 595 735 206 1 +656 812 636 398 1 +17 676 379 596 1 +111 519 110 1045 1 +863 615 1099 56 1 +382 169 367 766 1 +18 430 1021 982 1 +522 392 888 1000 1 +481 600 517 990 1 +928 803 783 748 1 +795 453 602 470 1 +486 781 395 898 1 +411 660 426 769 1 +736 697 521 725 1 +939 540 1103 210 1 +1097 980 337 1043 1 +787 1120 295 1125 1 +1002 699 177 370 1 +199 483 1064 1119 1 +738 860 1067 823 1 +317 868 894 899 1 +840 829 1004 1088 1 +694 448 1005 563 1 +770 633 780 949 1 +918 907 120 164 1 +744 145 699 370 1 +1109 53 677 689 1 +552 1023 638 1043 1 +718 949 780 385 1 +147 563 707 71 1 +736 410 354 521 1 +597 322 352 713 1 +50 519 793 838 1 +420 533 1132 337 1 +458 402 1124 211 1 +377 795 414 470 1 +311 644 312 884 1 +958 150 355 543 1 +1027 1059 867 897 1 +907 760 503 674 1 +816 646 513 1055 1 +44 500 936 974 1 +658 896 461 219 1 +687 617 705 820 1 +1112 365 505 752 1 +1013 752 695 884 1 +1077 752 884 365 1 +548 312 360 884 1 +1147 927 652 244 1 +549 854 1049 9 1 +657 147 563 707 1 +431 1052 1079 957 1 +31 873 545 264 1 +467 766 807 1039 1 +1130 504 347 1065 1 +397 424 1011 1058 1 +817 448 700 1005 1 +246 116 1059 72 1 +551 474 352 662 1 +621 1059 1027 554 1 +997 8 799 186 1 +725 297 736 697 1 +915 419 1031 776 1 +970 792 886 1084 1 +954 1031 846 949 1 +838 36 585 1092 1 +1052 880 673 847 1 +29 130 963 535 1 +757 944 10 252 1 +337 739 941 905 1 +391 1059 867 72 1 +324 1102 818 1018 1 +844 17 572 765 1 +167 397 813 396 1 +926 774 767 18 1 +909 104 791 341 1 +460 946 1107 553 1 +753 1042 1004 350 1 +611 717 1036 740 1 +411 587 316 769 1 +430 1090 871 706 1 +769 587 316 378 1 +698 849 870 1146 1 +1129 272 749 515 1 +514 871 1130 485 1 +65 861 690 495 1 +1065 514 1130 810 1 +1071 871 1130 3 1 +1115 681 889 913 1 +935 785 1038 1014 1 +514 3 1130 871 1 +809 514 3 1130 1 +755 681 889 1115 1 +485 1071 445 851 1 +590 704 1073 761 1 +861 677 537 534 1 +677 827 690 861 1 +1013 172 1057 1077 1 +484 250 922 346 1 +268 272 1129 242 1 +240 272 1129 268 1 +812 774 18 466 1 +668 381 373 423 1 +614 17 516 844 1 +240 749 1129 272 1 +698 553 717 1050 1 +734 1033 889 1096 1 +346 913 484 539 1 +484 913 681 539 1 +337 1023 941 714 1 +226 896 732 259 1 +57 127 1045 376 1 +812 951 774 398 1 +460 439 951 398 1 +909 739 289 1063 1 +66 62 484 141 1 +788 192 900 221 1 +1098 823 983 395 1 +1067 407 984 571 1 +558 466 774 862 1 +440 481 517 747 1 +488 481 440 747 1 +482 895 1034 1006 1 +848 1034 776 906 1 +205 652 794 891 1 +340 839 1123 901 1 +492 111 323 348 1 +707 71 563 1143 1 +447 950 359 881 1 +801 333 550 480 1 +434 418 792 780 1 +818 450 1029 1018 1 +776 906 936 44 1 +1116 309 701 1108 1 +279 904 952 247 1 +418 770 792 780 1 +460 882 656 430 1 +1076 1036 1073 590 1 +813 396 166 167 1 +954 902 1031 966 1 +726 819 1136 470 1 +922 346 409 994 1 +904 952 530 279 1 +138 96 247 952 1 +944 252 791 1138 1 +1006 1104 1034 930 1 +801 664 25 333 1 +291 730 446 891 1 +1017 1008 1020 716 1 +489 902 1026 915 1 +960 213 1139 729 1 +312 1048 884 1081 1 +993 1094 977 1016 1 +578 88 1001 417 1 +314 364 73 942 1 +659 889 922 343 1 +327 355 42 752 1 +655 913 889 745 1 +921 662 933 741 1 +149 180 857 521 1 +967 691 698 598 1 +350 744 950 370 1 +744 447 950 1002 1 +206 595 735 601 1 +509 522 354 521 1 +608 862 829 1132 1 +617 456 338 836 1 +306 705 678 208 1 +622 632 347 142 1 +627 774 767 926 1 +194 61 933 731 1 +921 933 61 741 1 +655 767 926 627 1 +655 926 342 627 1 +252 955 791 1138 1 +759 1106 876 331 1 +552 1043 638 97 1 +1083 407 574 1067 1 +489 978 965 902 1 +165 760 503 907 1 +624 467 400 402 1 +917 837 805 39 1 +97 638 160 362 1 +614 963 418 607 1 +151 150 355 958 1 +801 719 647 1072 1 +572 1072 647 719 1 +929 1131 488 440 1 +15 397 443 1137 1 +492 111 348 143 1 +1131 693 488 440 1 +864 969 488 1131 1 +1084 1108 658 228 1 +460 439 398 941 1 +903 487 173 1069 1 +706 485 757 687 1 +740 1026 1056 394 1 +252 104 757 791 1 +701 732 886 658 1 +1108 701 658 228 1 +909 739 786 289 1 +659 836 650 873 1 +374 511 917 674 1 +665 874 22 783 1 +416 728 674 917 1 +917 703 342 39 1 +416 703 917 39 1 +880 630 709 923 1 +496 548 312 947 1 +178 1002 760 1114 1 +103 809 347 1065 1 +727 840 994 627 1 +787 696 596 802 1 +510 331 1126 730 1 +165 877 48 503 1 +165 177 48 877 1 +503 877 48 653 1 +877 796 177 48 1 +653 796 877 48 1 +284 953 1144 646 1 +876 976 879 502 1 +887 682 994 727 1 +978 419 902 915 1 +802 1089 897 700 1 +431 1089 1027 1079 1 +472 401 850 1030 1 +401 967 719 415 1 +171 1112 151 393 1 +743 431 924 1089 1 +1089 573 897 700 1 +1112 1077 365 752 1 +421 329 918 565 1 +895 824 598 740 1 +993 502 1092 977 1 +1092 455 446 976 1 +657 731 670 322 1 +534 1078 1101 751 1 +707 1035 59 640 1 +1000 888 538 805 1 +431 864 743 567 1 +381 1128 39 589 1 +1049 761 549 590 1 +351 321 449 923 1 +1040 1012 961 912 1 +701 1116 479 964 1 +230 292 55 1062 1 +958 1040 679 961 1 +902 311 19 966 1 +681 913 331 730 1 +712 385 718 780 1 +782 469 981 927 1 +1028 655 1106 968 1 +689 381 589 1128 1 +601 1102 1018 672 1 +910 743 567 924 1 +350 420 878 1004 1 +138 12 96 980 1 +960 213 333 1139 1 +447 359 679 914 1 +596 923 880 847 1 +716 553 882 1008 1 +359 679 1114 447 1 +1049 854 637 9 1 +165 877 503 760 1 +706 944 757 791 1 +1144 1047 135 621 1 +1100 761 581 806 1 +643 748 1094 956 1 +1094 1016 386 992 1 +18 650 836 1021 1 +559 315 119 314 1 +984 1010 869 666 1 +693 344 488 440 1 +501 604 1005 700 1 +911 335 1017 491 1 +561 943 585 562 1 +752 393 355 1112 1 +56 984 819 625 1 +871 335 3 882 1 +364 972 692 641 1 +639 433 313 1142 1 +351 729 960 696 1 +354 888 538 522 1 +354 392 888 522 1 +534 1101 1078 736 1 +736 1078 782 224 1 +464 380 1005 817 1 +753 465 674 728 1 +1116 1025 390 308 1 +759 919 331 876 1 +225 231 1142 257 1 +512 1116 479 527 1 +880 932 1064 709 1 +854 591 406 618 1 +1102 44 822 1118 1 +440 929 1117 688 1 +302 422 1132 21 1 +637 1076 845 1020 1 +688 1148 863 56 1 +1013 695 752 364 1 +1077 752 1013 884 1 +1001 441 345 292 1 +107 607 41 490 1 +892 452 388 378 1 +803 452 892 378 1 +844 17 647 572 1 +693 344 495 488 1 +377 268 470 934 1 +626 631 594 883 1 +869 666 775 1028 1 +719 415 654 1105 1 +311 811 797 884 1 +998 23 704 777 1 +577 500 978 936 1 +750 630 233 787 1 +101 1091 161 540 1 +831 476 733 675 1 +378 575 388 892 1 +944 987 820 301 1 +522 1091 392 1000 1 +1022 39 856 1109 1 +604 448 1005 700 1 +951 398 812 460 1 +1113 642 497 555 1 +1032 868 738 860 1 +816 883 763 957 1 +872 534 779 725 1 +487 1069 903 53 1 +691 16 1095 462 1 +561 993 585 943 1 +579 1017 637 491 1 +735 1069 690 1029 1 +1019 108 999 109 1 +958 543 961 679 1 +410 99 959 354 1 +992 386 879 615 1 +987 873 650 820 1 +351 960 480 807 1 +150 179 679 34 1 +521 697 207 725 1 +1118 594 44 883 1 +583 1048 853 360 1 +337 905 941 830 1 +340 821 580 294 1 +312 360 1048 583 1 +982 764 460 946 1 +536 594 44 345 1 +342 1028 655 837 1 +150 34 679 958 1 +150 543 958 679 1 +676 847 596 776 1 +1045 127 384 1096 1 +1040 1041 497 914 1 +151 150 958 34 1 +942 326 1013 972 1 +340 821 901 580 1 +839 821 170 901 1 +706 485 871 757 1 +338 36 852 866 1 +960 490 351 664 1 +331 913 655 49 1 +672 1142 639 257 1 +903 663 689 53 1 +559 942 1013 364 1 +391 246 72 276 1 +745 484 922 346 1 +567 1131 864 929 1 +974 404 548 954 1 +419 500 978 542 1 +357 385 702 718 1 +635 328 689 371 1 +162 903 641 364 1 +162 173 641 903 1 +298 595 206 672 1 +318 198 247 904 1 +833 723 288 1054 1 +864 953 428 969 1 +315 364 162 314 1 +1047 131 531 833 1 +533 337 532 739 1 +910 713 863 600 1 +58 713 573 910 1 +461 649 560 875 1 +544 359 760 1002 1 +669 925 261 225 1 +1076 777 1008 720 1 +728 1012 806 1015 1 +1015 1012 806 961 1 +787 1052 880 1079 1 +1015 544 674 728 1 +665 874 783 916 1 +783 874 568 916 1 +105 104 920 10 1 +1016 977 585 892 1 +916 1014 1050 399 1 +671 832 642 512 1 +570 100 908 101 1 +404 708 1062 345 1 +801 333 25 550 1 +329 118 543 518 1 +22 866 874 665 1 +106 963 41 607 1 +713 586 573 910 1 +910 481 567 743 1 +58 481 910 743 1 +910 863 567 481 1 +600 863 910 481 1 +58 600 910 481 1 +105 920 514 485 1 +880 709 1064 435 1 +1038 1014 998 935 1 +326 1013 1081 172 1 +682 566 994 840 1 +942 172 1057 1013 1 +1081 1048 884 1013 1 +319 1 347 875 1 +794 410 1147 277 1 +1018 1102 818 822 1 +818 450 822 969 1 +830 656 882 911 1 +871 335 882 911 1 +1133 1020 649 461 1 +687 485 757 454 1 +890 779 666 962 1 +912 580 1123 901 1 +1045 323 808 755 1 +630 449 709 923 1 +750 293 233 630 1 +571 823 856 442 1 +758 487 903 371 1 +61 193 426 778 1 +447 881 914 638 1 +303 545 1066 265 1 +1020 637 491 1051 1 +1080 431 848 1034 1 +702 385 357 610 1 +424 445 851 940 1 +799 996 424 445 1 +1038 1006 899 23 1 +484 202 1033 250 1 +349 642 340 1123 1 +765 1056 1121 970 1 +523 518 329 421 1 +917 342 837 39 1 +704 489 1036 930 1 +781 486 663 898 1 +787 880 1052 596 1 +797 884 505 365 1 +416 917 374 39 1 +1021 430 1138 706 1 +768 917 703 342 1 +627 837 917 342 1 +814 501 1005 700 1 +920 104 341 757 1 +917 674 465 728 1 +703 917 465 728 1 +499 721 645 582 1 +329 907 120 918 1 +773 45 804 383 1 +962 986 547 775 1 +978 811 965 902 1 +978 419 915 936 1 +31 873 558 545 1 +562 943 221 304 1 +413 976 876 919 1 +885 1084 970 721 1 +327 752 663 559 1 +347 103 1065 142 1 +72 1079 1055 867 1 +397 1011 443 405 1 +921 788 221 61 1 +778 192 788 61 1 +505 797 468 811 1 +1099 879 625 56 1 +269 268 377 934 1 +943 788 900 221 1 +867 391 1079 897 1 +950 1002 1042 370 1 +750 293 630 449 1 +736 981 962 410 1 +944 301 757 10 1 +797 811 505 884 1 +237 301 944 10 1 +604 573 700 897 1 +436 659 922 558 1 +802 696 596 798 1 +142 1065 504 810 1 +393 1112 151 355 1 +752 393 1112 1077 1 +676 321 923 435 1 +676 321 351 923 1 +676 923 596 847 1 +676 435 923 847 1 +379 676 923 596 1 +379 676 351 923 1 +134 29 434 535 1 +819 470 56 859 1 +324 601 1102 1018 1 +134 29 108 434 1 +500 339 978 542 1 +119 328 74 315 1 +844 647 719 572 1 +449 41 293 1119 1 +110 285 384 127 1 +731 61 933 741 1 +1028 666 571 984 1 +1138 955 237 252 1 +18 982 460 430 1 +358 995 1087 582 1 +703 465 768 1060 1 +384 755 734 603 1 +889 484 1033 922 1 +1101 872 534 537 1 +1119 41 293 229 1 +304 386 943 584 1 +761 1100 581 1049 1 +630 923 750 449 1 +731 933 662 741 1 +844 572 719 765 1 +977 502 808 852 1 +396 166 452 378 1 +1037 17 379 596 1 +1139 213 187 47 1 +1017 319 491 335 1 +521 772 890 715 1 +366 609 628 940 1 +327 752 42 663 1 +944 1021 687 820 1 +969 65 1131 818 1 +752 961 841 505 1 +1001 483 536 1064 1 +1094 1135 625 785 1 +715 772 857 521 1 +72 276 1079 391 1 +957 1052 848 431 1 +611 870 717 698 1 +1052 673 848 847 1 +738 983 442 704 1 +42 543 329 1015 1 +589 1022 677 1109 1 +144 46 1093 52 1 +586 597 33 683 1 +33 643 317 683 1 +474 115 352 147 1 +499 654 995 1087 1 +756 1042 878 1004 1 +789 311 966 610 1 +643 894 992 1099 1 +115 147 71 629 1 +797 965 468 811 1 +746 965 549 19 1 +704 1073 581 442 1 +704 442 23 998 1 +1026 770 475 1056 1 +1026 475 770 633 1 +1049 14 937 579 1 +847 673 848 44 1 +1137 122 372 356 1 +605 367 425 1039 1 +723 953 833 82 1 +681 484 1096 889 1 +990 531 131 833 1 +1053 691 1095 598 1 +571 666 39 856 1 +837 571 39 342 1 +837 666 39 571 1 +783 988 22 803 1 +872 534 725 1101 1 +702 954 949 966 1 +918 330 389 68 1 +846 702 718 578 1 +455 457 446 976 1 +400 1139 807 382 1 +291 446 730 137 1 +916 619 946 764 1 +442 1067 998 571 1 +667 471 374 918 1 +1042 877 674 756 1 +916 619 874 946 1 +966 949 702 385 1 +761 489 590 704 1 +842 777 1073 834 1 +46 312 1093 156 1 +655 994 745 922 1 +715 872 779 725 1 +968 935 1028 342 1 +109 999 588 13 1 +1066 265 545 955 1 +935 571 1028 342 1 +366 940 628 831 1 +671 555 1025 642 1 +1067 984 935 571 1 +755 323 603 384 1 +976 457 446 891 1 +594 541 631 626 1 +455 934 457 976 1 +442 983 823 395 1 +807 382 1039 766 1 +390 273 308 1025 1 +795 240 1141 268 1 +97 552 160 638 1 +478 472 870 698 1 +320 472 870 478 1 +926 968 342 842 1 +835 18 764 968 1 +655 968 342 926 1 +619 835 764 968 1 +689 1109 486 781 1 +1066 466 862 955 1 +558 466 862 1066 1 +983 395 704 761 1 +478 870 611 698 1 +320 870 611 478 1 +956 575 1016 662 1 +449 1119 293 709 1 +171 52 1077 172 1 +564 427 971 451 1 +666 1022 865 779 1 +69 1091 161 101 1 +137 112 253 446 1 +384 285 734 1096 1 +1009 677 690 861 1 +1006 930 1034 738 1 +777 717 23 740 1 +1027 897 743 554 1 +913 745 346 484 1 +376 808 1045 1092 1 +919 502 808 1092 1 +688 574 1117 56 1 +1022 39 666 856 1 +746 1113 479 19 1 +755 681 1115 808 1 +978 983 738 704 1 +746 549 1113 19 1 +978 761 704 489 1 +823 666 1022 407 1 +1010 666 1022 865 1 +365 884 52 1093 1 +74 328 371 758 1 +787 880 630 1079 1 +948 323 348 437 1 +101 908 1091 540 1 +1055 621 867 1027 1 +688 574 567 1117 1 +1083 574 1117 567 1 +451 16 564 427 1 +1032 486 818 599 1 +943 307 221 304 1 +574 625 1135 899 1 +368 212 184 7 1 +986 510 1136 819 1 +307 921 209 584 1 +1044 318 390 964 1 +613 601 925 1102 1 +819 984 869 625 1 +852 336 1115 603 1 +240 1129 1141 268 1 +961 1012 1070 912 1 +430 851 871 1090 1 +852 759 1115 336 1 +1083 599 860 1032 1 +655 968 343 1106 1 +547 865 666 1010 1 +782 981 410 1147 1 +1117 1083 1010 574 1 +848 906 776 44 1 +777 717 1008 1107 1 +505 1070 468 797 1 +1070 549 965 797 1 +660 956 769 33 1 +1123 311 19 797 1 +1141 1129 859 268 1 +1070 761 549 1100 1 +279 904 247 198 1 +548 954 404 417 1 +811 841 978 468 1 +484 100 250 346 1 +419 811 978 902 1 +978 841 898 468 1 +579 830 1017 491 1 +211 402 814 1046 1 +882 335 3 1017 1 +1091 1000 979 540 1 +159 1046 211 246 1 +603 659 1115 889 1 +864 763 953 969 1 +829 862 636 1132 1 +94 254 1132 533 1 +1132 254 985 533 1 +956 769 928 748 1 +428 65 488 969 1 +579 830 937 1017 1 +356 754 850 1030 1 +830 911 1017 491 1 +408 1147 986 652 1 +20 628 678 733 1 +1128 1109 781 856 1 +1062 708 925 669 1 +1109 39 856 1128 1 +1091 979 526 161 1 +959 893 888 49 1 +226 1 896 256 1 +1148 688 726 56 1 +518 524 559 119 1 +534 855 1078 751 1 +75 959 408 410 1 +75 99 959 410 1 +423 381 39 589 1 +381 429 423 39 1 +416 856 39 1128 1 +681 484 286 1096 1 +806 781 856 1128 1 +381 429 39 565 1 +870 851 1071 553 1 +598 379 1053 895 1 +846 578 535 1001 1 +795 1141 470 268 1 +842 571 703 442 1 +961 781 806 42 1 +468 781 806 961 1 +989 925 595 298 1 +747 440 477 602 1 +493 482 1111 1089 1 +522 888 538 1000 1 +772 857 521 522 1 +871 706 757 791 1 +691 462 1095 967 1 +772 522 538 1000 1 +529 813 403 332 1 +595 972 989 73 1 +17 596 1037 1104 1 +222 989 73 298 1 +957 631 44 673 1 +812 985 636 862 1 +24 508 616 552 1 +812 791 985 955 1 +902 811 965 19 1 +785 1094 612 625 1 +320 1133 649 461 1 +1025 217 273 308 1 +795 602 267 241 1 +1136 377 927 414 1 +974 847 44 536 1 +716 1020 1017 649 1 +589 779 677 1022 1 +1109 599 53 486 1 +1084 473 249 228 1 +918 330 421 389 1 +1010 666 407 1022 1 +953 1145 513 283 1 +698 765 478 401 1 +394 966 633 949 1 +419 915 1031 902 1 +1031 394 770 949 1 +1009 1083 599 865 1 +1089 493 573 700 1 +956 575 662 660 1 +115 629 325 352 1 +598 895 740 1037 1 +396 397 1058 366 1 +572 379 1037 17 1 +621 76 117 520 1 +610 479 19 966 1 +937 1076 1073 1049 1 +36 603 338 852 1 +346 1061 913 539 1 +952 1043 406 1122 1 +975 753 465 714 1 +937 975 834 439 1 +735 148 690 387 1 +71 76 629 117 1 +763 431 1027 957 1 +735 601 641 1069 1 +1024 647 17 379 1 +522 69 1091 526 1 +818 450 65 1029 1 +434 108 13 999 1 +600 1141 1148 453 1 +1076 777 720 834 1 +1076 937 579 1049 1 +730 681 62 1074 1 +879 993 386 1094 1 +1077 52 1081 172 1 +904 875 491 1051 1 +964 390 1044 1116 1 +326 1081 156 172 1 +1081 52 156 172 1 +751 1075 537 534 1 +626 883 1007 631 1 +536 441 1064 541 1 +976 1092 919 446 1 +836 820 456 1021 1 +905 337 532 1122 1 +911 830 905 1122 1 +473 721 885 310 1 +789 548 938 954 1 +928 451 564 971 1 +817 971 564 427 1 +33 971 564 817 1 +33 928 564 971 1 +33 643 971 317 1 +33 643 928 971 1 +736 1078 981 782 1 +828 861 157 1075 1 +748 785 399 928 1 +971 785 317 643 1 +928 785 971 643 1 +200 245 512 1116 1 +114 287 990 131 1 +364 73 972 641 1 +354 736 890 893 1 +215 1088 1134 878 1 +24 508 552 97 1 +533 532 129 739 1 +456 874 982 1090 1 +974 500 853 708 1 +419 500 853 974 1 +974 44 708 345 1 +625 984 869 1106 1 +1124 729 1139 1127 1 +491 875 1017 1020 1 +564 988 451 928 1 +738 915 1034 906 1 +836 18 982 835 1 +694 1005 1035 563 1 +783 928 988 803 1 +988 1146 783 568 1 +975 753 728 465 1 +881 753 728 975 1 +676 776 596 17 1 +664 490 351 1024 1 +812 460 656 430 1 +923 880 847 435 1 +944 706 687 1021 1 +443 754 368 356 1 +478 401 995 1105 1 +112 1092 67 446 1 +654 801 1087 661 1 +578 38 88 938 1 +1124 1139 47 1127 1 +456 619 836 982 1 +565 667 374 918 1 +400 47 1124 1139 1 +887 727 994 627 1 +655 887 994 627 1 +1095 16 605 462 1 +1072 967 572 1095 1 +565 918 374 907 1 +502 993 976 879 1 +994 774 767 627 1 +655 784 745 994 1 +784 908 745 994 1 +1084 1108 712 479 1 +585 36 977 1092 1 +400 1139 1124 696 1 +784 682 994 887 1 +301 687 722 236 1 +908 682 994 784 1 +163 1057 559 942 1 +1067 899 23 998 1 +26 790 525 155 1 +978 542 898 841 1 +811 542 978 841 1 +712 527 385 479 1 +533 254 985 739 1 +339 898 978 542 1 +338 619 835 836 1 +940 366 1058 424 1 +544 1012 728 1015 1 +339 613 1102 324 1 +702 954 846 949 1 +596 1104 776 1111 1 +397 1011 405 1058 1 +49 893 888 775 1 +915 902 1026 394 1 +138 12 980 532 1 +679 359 1040 914 1 +961 468 1070 1012 1 +983 468 395 761 1 +978 468 983 761 1 +499 1087 218 661 1 +690 735 1029 353 1 +729 213 1139 1127 1 +719 801 790 1087 1 +109 1086 155 588 1 +9 555 671 1113 1 +664 790 647 801 1 +1051 318 637 904 1 +753 1042 674 1004 1 +559 663 328 315 1 +544 881 728 1012 1 +801 790 647 719 1 +801 525 790 1087 1 +790 525 155 1087 1 +78 686 313 639 1 +1139 213 333 187 1 +664 26 1086 790 1 +639 686 313 353 1 +479 671 1116 512 1 +765 1133 478 970 1 +475 845 945 1133 1 +1133 945 475 1121 1 +611 945 1133 1121 1 +775 893 538 890 1 +461 875 560 896 1 +956 643 683 992 1 +500 339 577 978 1 +516 1086 607 1019 1 +663 752 42 781 1 +545 955 237 1138 1 +711 36 338 866 1 +452 866 557 711 1 +892 866 803 748 1 +588 1086 155 358 1 +481 833 990 517 1 +481 531 600 990 1 +990 77 749 287 1 +114 77 990 287 1 +990 77 325 749 1 +114 77 325 990 1 +795 602 241 414 1 +851 445 991 940 1 +851 445 485 991 1 +989 583 613 925 1 +976 502 919 1092 1 +739 905 532 1063 1 +753 1004 465 714 1 +1069 53 487 690 1 +596 880 1052 847 1 +655 994 767 627 1 +566 558 994 840 1 +992 894 910 863 1 +683 894 910 992 1 +564 425 464 817 1 +992 683 713 910 1 +615 992 713 863 1 +1069 53 690 1029 1 +872 779 534 438 1 +129 1063 289 739 1 +840 774 994 627 1 +1144 953 82 833 1 +846 949 718 702 1 +937 830 720 1017 1 +993 977 1092 585 1 +561 993 1092 585 1 +566 558 922 994 1 +994 558 767 774 1 +840 558 994 774 1 +423 39 1022 589 1 +840 1004 727 1088 1 +1088 840 651 727 1 +1004 756 727 1088 1 +503 877 653 756 1 +712 434 718 134 1 +282 712 718 134 1 +1133 945 611 1008 1 +921 662 741 209 1 +1133 716 1008 611 1 +1015 961 806 42 1 +545 1138 987 650 1 +185 8 184 997 1 +1139 960 729 696 1 +147 563 71 629 1 +997 634 8 184 1 +957 431 1027 1079 1 +548 966 902 954 1 +9 555 1113 854 1 +511 653 1103 727 1 +866 338 874 665 1 +475 845 1133 886 1 +1026 633 394 966 1 +459 269 243 205 1 +674 544 1015 760 1 +760 543 1015 907 1 +450 353 1018 639 1 +352 563 629 713 1 +622 212 369 560 1 +397 754 1011 424 1 +780 535 418 614 1 +629 76 115 520 1 +629 520 554 117 1 +122 528 15 1137 1 +429 772 805 1000 1 +484 539 681 62 1 +1054 723 139 1068 1 +80 872 1003 715 1 +438 223 872 80 1 +157 537 223 375 1 +1003 668 438 176 1 +182 668 1003 176 1 +1003 176 438 80 1 +182 176 1003 80 1 +1104 930 1006 740 1 +180 80 715 725 1 +1006 895 1034 1104 1 +80 872 715 725 1 +1003 507 715 373 1 +668 1003 715 373 1 +71 1143 707 159 1 +1004 840 774 829 1 +627 840 774 1004 1 +465 1004 768 439 1 +465 714 1004 439 1 +917 1004 768 465 1 +917 674 1004 465 1 +459 457 976 891 1 +887 727 627 1004 1 +1050 764 1107 815 1 +406 579 1043 854 1 +442 856 395 823 1 +948 40 437 271 1 +1059 246 1046 501 1 +1058 405 813 332 1 +917 1004 887 627 1 +917 674 887 1004 1 +547 1010 1082 865 1 +406 96 11 1043 1 +547 962 666 865 1 +895 1104 1006 740 1 +777 1008 720 1107 1 +470 377 413 1136 1 +17 676 1024 379 1 +1024 647 379 480 1 +1112 752 505 961 1 +981 1136 1082 986 1 +260 229 199 1064 1 +816 763 646 1027 1 +1018 822 450 433 1 +584 515 272 1129 1 +486 53 818 599 1 +1009 53 677 599 1 +690 53 677 1009 1 +873 659 1033 436 1 +587 191 378 826 1 +873 1033 263 436 1 +496 789 311 548 1 +693 477 444 751 1 +873 234 263 1033 1 +619 336 968 612 1 +792 1084 633 886 1 +271 437 705 492 1 +721 886 1133 461 1 +659 734 1033 889 1 +922 659 1033 889 1 +703 842 442 1060 1 +56 984 1010 819 1 +723 833 1068 1054 1 +18 343 926 968 1 +659 948 734 603 1 +726 56 1082 819 1 +603 1115 808 755 1 +495 1075 93 344 1 +1099 894 992 863 1 +828 861 1075 495 1 +460 812 18 430 1 +314 73 162 163 1 +521 890 354 736 1 +354 772 890 521 1 +320 870 716 611 1 +979 540 939 161 1 +945 1026 475 1121 1 +565 1128 518 42 1 +665 612 1014 748 1 +665 1014 619 916 1 +665 612 619 1014 1 +1014 785 399 748 1 +665 1014 399 748 1 +565 1015 329 907 1 +359 543 961 1012 1 +543 544 1015 1012 1 +987 650 1138 820 1 +1015 760 907 674 1 +565 1015 907 674 1 +720 882 460 553 1 +379 1072 572 1095 1 +379 1095 572 598 1 +977 852 892 1094 1 +768 842 703 1060 1 +611 716 717 870 1 +185 443 184 153 1 +1046 402 814 501 1 +581 465 1060 975 1 +1002 699 37 177 1 +581 465 703 1060 1 +1016 943 386 584 1 +515 1016 386 584 1 +660 426 933 670 1 +852 759 336 612 1 +636 398 941 656 1 +850 368 369 754 1 +585 943 1016 900 1 +939 540 653 1103 1 +17 776 596 1104 1 +411 670 804 196 1 +1074 1096 681 286 1 +1088 651 1134 727 1 +912 1070 1041 1012 1 +871 335 514 3 1 +967 462 1030 691 1 +754 472 850 1030 1 +855 1078 444 981 1 +1052 802 1079 787 1 +828 827 157 861 1 +754 472 1030 849 1 +1030 967 415 462 1 +975 465 1060 439 1 +413 470 819 859 1 +320 611 1133 478 1 +320 716 649 1133 1 +720 553 460 1107 1 +1008 1107 553 720 1 +123 587 35 166 1 +18 1021 430 1138 1 +964 1020 845 886 1 +964 732 1020 886 1 +834 842 777 1107 1 +1107 1050 815 717 1 +987 1138 944 820 1 +552 1023 881 638 1 +842 998 1107 764 1 +669 1118 708 925 1 +1118 44 708 1102 1 +1023 579 830 937 1 +941 1023 830 937 1 +975 14 1023 937 1 +1107 998 815 764 1 +1023 975 937 439 1 +941 1023 937 439 1 +1023 714 975 439 1 +941 714 1023 439 1 +987 1138 237 944 1 +975 14 881 1023 1 +753 714 975 1023 1 +1107 998 777 815 1 +1097 552 1023 350 1 +753 1023 881 552 1 +753 975 881 1023 1 +350 1023 753 552 1 +350 714 753 1023 1 +366 609 940 1058 1 +1026 489 965 902 1 +447 37 724 179 1 +1115 889 343 655 1 +746 902 966 1026 1 +1079 880 1007 957 1 +835 343 18 968 1 +417 853 583 858 1 +417 858 583 55 1 +531 1027 864 743 1 +531 646 864 1027 1 +276 1046 1120 391 1 +853 925 583 858 1 +580 821 901 34 1 +1063 532 909 905 1 +946 916 1050 568 1 +816 763 1027 957 1 +1037 740 765 1056 1 +1050 824 815 717 1 +770 1056 970 475 1 +637 964 1051 1020 1 +964 1044 1051 732 1 +417 1062 853 858 1 +946 1050 553 851 1 +946 1050 851 568 1 +345 541 536 594 1 +916 764 946 1050 1 +408 510 891 652 1 +333 213 146 187 1 +703 442 581 1060 1 +575 192 900 788 1 +889 655 922 343 1 +659 343 922 767 1 +266 235 409 566 1 +659 343 767 835 1 +478 995 721 560 1 +336 659 835 343 1 +1064 199 260 441 1 +767 343 922 655 1 +1065 1130 504 810 1 +682 566 266 409 1 +614 17 1031 676 1 +614 17 770 1031 1 +616 508 95 1097 1 +614 847 1031 846 1 +1031 676 776 847 1 +614 676 1031 847 1 +932 229 260 1064 1 +541 441 230 345 1 +846 847 1031 536 1 +434 473 249 1084 1 +1048 695 884 1013 1 +695 1013 1048 972 1 +458 402 211 159 1 +930 915 1034 738 1 +499 1105 850 369 1 +560 995 721 499 1 +743 554 531 1027 1 +746 590 1076 1049 1 +607 963 418 1019 1 +559 1013 752 364 1 +531 76 621 520 1 +1047 76 621 531 1 +962 981 1082 986 1 +248 621 867 1055 1 +1036 611 1008 717 1 +777 1036 1008 717 1 +876 413 879 976 1 +688 863 574 56 1 +1047 76 135 621 1 +432 185 997 186 1 +163 172 171 1057 1 +167 432 397 366 1 +1058 940 851 609 1 +1109 1022 677 599 1 +603 835 659 836 1 +572 1037 765 17 1 +598 1037 765 572 1 +598 740 765 1037 1 +1038 317 1006 824 1 +1038 399 971 824 1 +317 1038 971 824 1 +317 785 971 1038 1 +992 956 1016 662 1 +618 273 390 555 1 +1039 766 569 380 1 +425 1039 569 380 1 +1039 367 569 766 1 +425 367 569 1039 1 +1042 1002 877 370 1 +606 1040 497 914 1 +901 34 1040 580 1 +1040 580 606 497 1 +912 580 1040 497 1 +1040 606 580 34 1 +679 606 1040 34 1 +464 597 660 33 1 +322 670 660 933 1 +660 597 956 33 1 +643 1094 1099 992 1 +1099 879 1094 625 1 +1004 1042 878 350 1 +844 719 995 765 1 +765 572 719 401 1 +952 96 406 1043 1 +362 97 638 591 1 +1107 717 1008 553 1 +1053 691 598 824 1 +921 1016 943 788 1 +764 951 460 1107 1 +832 349 1123 642 1 +864 1068 428 953 1 +231 593 1142 78 1 +885 721 358 310 1 +624 380 766 467 1 +788 1016 943 900 1 +848 1080 1034 906 1 +866 452 892 803 1 +1138 430 791 706 1 +644 46 312 1093 1 +838 1092 1045 36 1 +94 533 420 1097 1 +793 838 1045 36 1 +793 838 519 1045 1 +111 793 1045 323 1 +111 793 519 1045 1 +575 956 892 769 1 +378 575 892 769 1 +892 900 388 585 1 +892 1016 900 585 1 +309 1116 6 308 1 +378 426 575 769 1 +544 1002 1042 950 1 +442 1067 23 998 1 +583 326 989 1048 1 +248 867 72 1055 1 +867 116 72 1059 1 +451 988 16 1011 1 +986 962 547 1082 1 +547 865 1082 962 1 +1083 1117 1010 865 1 +621 116 867 1059 1 +691 1011 462 1030 1 +1048 339 542 695 1 +972 339 1048 695 1 +1147 408 986 893 1 +853 339 542 1048 1 +854 1041 549 1049 1 +845 1049 9 746 1 +854 497 549 1041 1 +1117 1082 865 440 1 +232 1079 1055 72 1 +171 52 170 1077 1 +550 480 382 605 1 +460 430 946 553 1 +637 1049 9 845 1 +339 486 818 577 1 +1074 57 137 376 1 +474 731 352 662 1 +732 1051 258 1044 1 +732 226 258 1051 1 +198 875 278 904 1 +226 875 198 1051 1 +595 925 601 672 1 +939 1103 275 210 1 +258 318 1044 1051 1 +1051 198 318 904 1 +258 198 318 1051 1 +226 198 258 1051 1 +185 997 443 397 1 +182 667 373 389 1 +581 975 1073 1049 1 +18 1138 812 466 1 +583 925 853 613 1 +493 817 1053 317 1 +44 848 957 673 1 +1053 824 317 971 1 +895 824 317 1053 1 +1053 379 807 798 1 +1094 852 892 748 1 +1053 482 317 895 1 +493 482 1053 1111 1 +493 482 317 1053 1 +1053 493 467 817 1 +427 1053 467 817 1 +1053 807 467 798 1 +427 807 467 1053 1 +628 991 456 733 1 +173 737 641 735 1 +122 443 356 1137 1 +816 1027 646 1055 1 +854 555 1113 497 1 +232 1055 248 72 1 +356 1011 462 405 1 +227 318 247 11 1 +1080 763 864 969 1 +924 431 567 1080 1 +962 855 865 1082 1 +1068 488 344 747 1 +125 45 804 773 1 +891 794 290 408 1 +811 419 548 902 1 +868 1080 1034 924 1 +719 1105 995 401 1 +478 369 1105 560 1 +401 415 1105 850 1 +478 995 560 1105 1 +790 647 1110 516 1 +352 563 147 629 1 +1114 679 359 543 1 +1058 332 813 396 1 +384 323 603 948 1 +397 405 813 1058 1 +595 601 206 672 1 +1059 897 501 1046 1 +452 628 22 711 1 +1061 908 346 745 1 +49 908 1061 745 1 +908 100 1061 346 1 +570 1061 392 908 1 +570 100 1061 908 1 +570 66 1061 100 1 +570 1061 800 392 1 +570 66 800 1061 1 +292 417 55 1062 1 +210 275 685 1103 1 +210 1103 685 682 1 +150 178 543 1114 1 +785 1135 625 899 1 +643 894 1099 1135 1 +756 370 878 1042 1 +877 370 756 1042 1 +760 51 907 165 1 +873 234 734 948 1 +787 923 880 596 1 +86 610 789 357 1 +932 1064 260 541 1 +693 477 751 1075 1 +66 539 346 484 1 +541 536 631 1064 1 +581 856 442 703 1 +738 983 823 442 1 +342 571 703 842 1 +571 442 856 703 1 +1078 469 444 981 1 +439 460 834 720 1 +439 951 834 460 1 +941 460 720 656 1 +941 439 720 460 1 +751 537 1075 375 1 +457 934 243 459 1 +317 894 643 785 1 +643 1135 1094 785 1 +643 1099 1094 1135 1 +1006 868 899 1067 1 +1067 23 1006 738 1 +868 1067 1006 738 1 +1012 1100 806 468 1 +1100 975 728 581 1 +426 826 575 778 1 +484 250 286 202 1 +881 1100 1012 1041 1 +736 297 1078 224 1 +443 997 184 754 1 +1041 1100 1049 14 1 +881 975 728 1100 1 +701 259 658 228 1 +754 634 997 184 1 +941 714 398 829 1 +1134 215 796 275 1 +1088 1134 878 756 1 +414 927 1136 469 1 +153 184 7 368 1 +173 735 641 1069 1 +185 997 184 443 1 +877 1134 796 653 1 +1147 244 794 277 1 +849 1011 698 1030 1 +499 654 1105 995 1 +374 907 471 503 1 +996 870 851 1071 1 +320 504 1071 870 1 +1032 969 1131 818 1 +504 996 1071 870 1 +1032 1131 1009 818 1 +716 1071 3 882 1 +716 553 1071 882 1 +1071 870 716 320 1 +3 1071 716 320 1 +889 755 1096 681 1 +1074 127 376 1096 1 +941 829 636 337 1 +381 39 1128 565 1 +285 1033 1096 202 1 +1072 462 415 967 1 +463 462 415 1072 1 +1072 801 719 412 1 +415 463 1072 412 1 +1140 901 355 1112 1 +1139 333 480 550 1 +1072 412 719 415 1 +967 1072 719 415 1 +889 755 734 1096 1 +86 128 789 938 1 +976 934 457 459 1 +428 65 969 450 1 +414 1136 726 469 1 +612 1106 876 759 1 +427 691 971 451 1 +739 812 636 656 1 +273 216 497 591 1 +775 1028 1106 869 1 +775 1106 331 869 1 +336 1106 968 612 1 +759 502 919 876 1 +808 502 919 759 1 +1036 777 1076 1073 1 +1114 1002 760 359 1 +178 37 1114 179 1 +93 84 495 344 1 +1017 720 1076 1008 1 +1017 720 937 1076 1 +1076 1008 1020 1017 1 +637 1076 1020 1017 1 +579 1076 637 1017 1 +579 937 1076 1017 1 +726 1136 981 469 1 +1049 1076 1073 590 1 +540 511 682 784 1 +653 275 1103 727 1 +1111 379 596 1037 1 +766 169 367 168 1 +1029 735 601 353 1 +1029 735 1069 601 1 +150 178 1114 179 1 +704 1073 442 998 1 +1079 276 787 391 1 +232 276 1079 72 1 +958 901 961 355 1 +1080 957 848 431 1 +818 822 906 1032 1 +906 822 1080 1032 1 +906 822 848 1080 1 +822 763 1080 969 1 +822 957 848 1080 1 +956 643 992 1094 1 +642 294 340 580 1 +312 583 1081 156 1 +312 583 1048 1081 1 +880 1064 847 435 1 +56 1010 1082 819 1 +984 869 1010 819 1 +986 1136 652 927 1 +516 614 607 1024 1 +607 614 321 1024 1 +1082 865 440 444 1 +726 1082 440 444 1 +981 1082 726 444 1 +1082 855 865 444 1 +842 968 935 1014 1 +407 860 1067 1083 1 +1022 1083 1010 865 1 +1022 599 1083 865 1 +1009 693 1083 865 1 +345 1118 708 669 1 +693 440 1083 865 1 +180 80 1003 715 1 +852 1115 808 603 1 +983 486 860 1098 1 +1098 486 860 599 1 +603 889 1115 755 1 +93 1075 157 375 1 +331 681 1115 913 1 +464 660 769 33 1 +864 428 488 969 1 +608 985 1132 422 1 +545 466 558 1066 1 +629 58 604 554 1 +831 186 799 675 1 +604 58 573 554 1 +563 713 604 629 1 +563 713 448 604 1 +604 897 501 1059 1 +342 935 842 968 1 +342 571 842 935 1 +785 894 643 1135 1 +106 483 963 130 1 +842 968 1014 764 1 +941 714 439 398 1 +869 984 1028 1106 1 +370 145 699 796 1 +625 984 1106 935 1 +785 894 1135 899 1 +26 1086 607 664 1 +574 984 625 899 1 +26 607 107 664 1 +1034 431 848 1089 1 +215 302 1088 878 1 +452 190 592 762 1 +571 666 823 407 1 +431 1089 743 1027 1 +171 1077 1112 393 1 +839 365 505 1112 1 +1027 1089 743 897 1 +1034 431 1089 924 1 +342 571 39 703 1 +874 711 628 456 1 +1027 1089 897 1079 1 +431 1052 1089 1079 1 +1102 822 1018 433 1 +1090 874 946 851 1 +864 1068 481 488 1 +555 1025 648 273 1 +369 212 634 184 1 +44 1102 822 500 1 +44 708 1102 500 1 +501 246 1046 159 1 +446 112 376 137 1 +112 376 1045 1092 1 +658 1084 228 473 1 +626 932 1007 262 1 +57 376 1045 112 1 +1018 324 1029 818 1 +486 324 53 692 1 +67 455 1092 561 1 +1092 993 455 976 1 +502 993 1092 976 1 +324 339 486 818 1 +1018 601 1029 324 1 +956 748 1094 892 1 +993 502 1094 879 1 +993 502 977 1094 1 +105 920 454 10 1 +446 1092 376 112 1 +643 748 785 1094 1 +94 533 1097 508 1 +977 502 852 1094 1 +1094 876 879 502 1 +625 876 879 1094 1 +748 1094 612 785 1 +748 852 612 1094 1 +612 876 625 1094 1 +954 536 846 1031 1 +612 502 876 1094 1 +338 866 852 665 1 +262 293 630 233 1 +1008 720 882 1017 1 +675 831 20 733 1 +264 271 873 236 1 +515 662 1016 584 1 +1007 932 880 630 1 +1097 533 980 508 1 +94 533 508 12 1 +1125 729 295 750 1 +721 473 658 219 1 +956 992 597 662 1 +933 575 662 921 1 +669 1118 925 225 1 +574 1067 899 868 1 +519 1045 838 1092 1 +984 1067 899 574 1 +663 689 53 486 1 +1070 761 468 965 1 +797 1070 468 965 1 +574 863 1099 56 1 +574 863 894 1099 1 +581 975 1049 1100 1 +1022 1109 1098 599 1 +1114 679 179 447 1 +1100 581 728 806 1 +1012 1100 728 806 1 +94 533 1132 420 1 +1041 1100 549 1049 1 +1041 1070 549 1100 1 +746 549 9 1113 1 +738 442 23 704 1 +704 738 489 930 1 +356 1030 462 1011 1 +887 511 784 682 1 +24 552 724 160 1 +898 663 841 695 1 +873 234 1033 734 1 +1031 1104 776 17 1 +1034 915 776 906 1 +1112 839 365 170 1 +171 1077 170 1112 1 +282 357 712 527 1 +1031 17 776 676 1 +1022 599 860 1083 1 +1064 1119 709 229 1 +438 677 537 827 1 +84 132 1068 723 1 +57 1045 519 112 1 +560 1105 499 369 1 +451 16 427 691 1 +262 293 709 630 1 +694 322 464 448 1 +657 731 322 147 1 +657 322 563 147 1 +738 1067 442 823 1 +713 322 352 563 1 +612 1106 625 876 1 +768 1004 774 398 1 +714 398 829 1004 1 +714 439 398 1004 1 +1089 802 897 1079 1 +746 1026 590 965 1 +901 821 170 34 1 +726 1136 1082 981 1 +200 1108 712 249 1 +200 527 712 1108 1 +377 470 413 934 1 +712 1108 1084 249 1 +200 228 1108 249 1 +1108 886 479 1084 1 +701 886 479 1108 1 +337 1043 980 1122 1 +701 658 886 1108 1 +886 1108 658 1084 1 +535 434 134 718 1 +418 885 970 844 1 +885 844 358 995 1 +970 844 885 995 1 +254 955 786 204 1 +1123 1070 549 912 1 +418 885 434 792 1 +418 999 434 885 1 +1011 754 849 424 1 +790 647 719 1110 1 +963 535 418 1019 1 +963 29 535 1019 1 +434 29 1019 535 1 +535 418 434 780 1 +339 898 577 978 1 +535 846 718 578 1 +965 902 746 1026 1 +535 1019 434 418 1 +405 16 332 988 1 +848 1111 596 776 1 +1111 1104 776 1034 1 +848 1111 776 1034 1 +1053 1111 798 493 1 +1053 379 798 1111 1 +361 593 78 283 1 +746 945 1076 590 1 +590 489 1026 1036 1 +945 590 1026 1036 1 +1026 590 945 746 1 +965 902 19 746 1 +178 37 1002 1114 1 +1007 880 631 957 1 +98 1126 800 539 1 +447 37 179 1114 1 +999 1110 358 844 1 +205 244 290 794 1 +816 883 957 1007 1 +603 659 336 1115 1 +336 343 1106 1115 1 +1115 659 343 889 1 +1106 968 343 336 1 +611 824 717 740 1 +331 1115 655 913 1 +1105 995 560 499 1 +1106 343 655 1115 1 +701 1116 6 309 1 +701 1044 6 1116 1 +1121 1133 970 475 1 +322 464 597 660 1 +1026 770 394 633 1 +478 970 1133 721 1 +991 733 476 687 1 +73 364 162 641 1 +762 348 678 628 1 +672 1118 771 225 1 +672 925 1118 225 1 +672 1118 433 771 1 +672 1102 433 1118 1 +1118 883 822 433 1 +771 883 1118 433 1 +1118 822 1102 433 1 +220 733 675 306 1 +733 476 220 675 1 +991 733 628 940 1 +628 617 678 733 1 +744 24 616 552 1 +552 447 744 724 1 +71 629 563 1143 1 +30 813 529 123 1 +671 964 390 9 1 +1133 845 945 1020 1 +479 832 671 512 1 +386 1129 615 515 1 +1113 9 479 671 1 +337 420 829 1132 1 +1097 420 714 337 1 +1079 1027 1055 867 1 +698 824 611 765 1 +1125 211 295 1124 1 +140 88 292 1001 1 +1121 1036 1026 740 1 +945 1036 1026 1121 1 +611 740 1036 1121 1 +904 491 911 1122 1 +1122 532 911 952 1 +905 532 911 1122 1 +1122 579 830 1023 1 +337 1122 830 1023 1 +1043 1122 337 1023 1 +1043 579 1122 1023 1 +460 946 764 1107 1 +660 426 575 933 1 +617 948 348 437 1 +549 912 1041 497 1 +1107 815 777 717 1 +507 70 1000 471 1 +569 124 168 367 1 +976 502 876 919 1 +1120 211 1125 814 1 +696 1125 787 923 1 +696 729 1125 923 1 +775 1126 986 510 1 +630 880 1007 1079 1 +1125 729 750 923 1 +787 1125 750 923 1 +896 1 875 843 1 +800 1126 1061 539 1 +443 754 356 1011 1 +587 396 316 378 1 +98 1126 408 959 1 +98 539 1085 1126 1 +327 518 559 663 1 +1015 416 42 806 1 +1061 1126 49 913 1 +1061 959 49 1126 1 +98 133 539 66 1 +800 539 1061 66 1 +800 959 1061 1126 1 +98 539 800 66 1 +98 959 800 1126 1 +806 856 416 1128 1 +98 1126 1085 408 1 +211 402 1124 814 1 +42 416 1128 806 1 +1015 416 565 42 1 +514 1130 809 1065 1 +320 1130 3 1071 1 +320 504 1130 1071 1 +1007 932 630 262 1 +326 73 989 972 1 +504 1071 445 1130 1 +347 1130 3 320 1 +347 504 1130 320 1 +1131 1083 693 440 1 +1131 1083 868 1032 1 +1080 1131 868 1032 1 +1088 302 608 1132 1 +361 593 283 201 1 +1083 440 929 1117 1 +1083 1131 868 567 1 +1083 1117 929 567 1 +1080 1131 567 868 1 +1099 56 625 574 1 +420 533 337 1097 1 +302 608 1132 422 1 +875 319 491 1017 1 +765 1121 1133 970 1 +765 1121 611 1133 1 +1107 460 720 834 1 +777 1107 720 834 1 +1107 951 834 842 1 +226 1 875 896 1 +1045 1096 755 376 1 +569 620 380 624 1 +1099 574 625 1135 1 Normals -678 -0.410023791408203 0.358830140045326 -0.838523357500728 --0.00589446086828757 0.31792717893144 -0.94809681163253 -0.00292876577808761 0.585199571905015 -0.810884013514389 --0.00617905359556138 -0.0179837449026721 -0.999819185761075 -0.695017254814457 -0.0039635725041701 -0.718982131629973 -0.555992749614091 0.723514898617491 -0.409143317011392 -0.00378510773021062 0.785458573501733 -0.618902659771384 --0.405983539918211 0.385907455739883 -0.828403766843107 -0.42453275038318 -0.348367681157065 -0.835710417894465 -0.00562418643448398 -0.359796658297774 -0.933013790468665 -0.829007003644962 0.396766121745759 -0.394111700590621 -0.00307692347264389 0.965586615232904 -0.260063494218251 --0.448783875919757 0.701453904049295 -0.55367450113622 --0.434195261406813 -0.35441277331123 -0.828170309227343 --0.0105761758003709 -0.54170396014397 -0.840502804319998 -0.658519105657338 0.751479522508405 0.0403870614776604 -0.823743836383659 0.566962157348201 -6.44593393453242e-05 -0.342098411815832 0.939508299817211 0.0171123115814167 -0.844607087050101 -0.389095106849258 -0.367755171725303 -0.970198108029631 0.242225397526783 -0.00651827958249946 --0.00415879353200373 0.993667314369323 0.112285229618214 --0.780049168248092 -0.0145312144317472 -0.625549469604602 -0.998359884002043 0.0565706771790876 -0.00879207022985 -0.482344708979139 -0.768121924670272 -0.421108407136055 --0.340262357692468 0.94026584318929 -0.0110305062937329 -0.0123749848509551 -0.773212864345485 -0.634025808749604 -0.960253819628469 -0.278709978043098 0.0152757987729413 --0.85681745319442 0.312253010172538 -0.410319277562749 -0.854012764837169 0.336702678190978 0.396602450817183 --0.64603215612611 0.762858616552568 0.0262523218506964 --0.0132879435197614 0.951707564416381 0.306718343744965 -0.783466196706416 -0.621048608934592 0.0218939251572532 -0.452150699705443 0.761966667328873 0.463644845367237 --0.510739025798429 -0.750442097515197 -0.419502450294945 --0.83491280264769 0.549062462507994 -0.0380923120804743 -0.0075074135760312 -0.960892006762706 -0.276821585287236 -0.61458764588251 -0.788411632584021 -0.0262511549230346 --0.849464580424672 -0.330295553133378 -0.411478765168084 -0.832240372300367 -0.372557346272638 0.410581278739832 --0.940758833058406 0.339073338191374 -0.00144545852393642 -0.00045319913813425 0.764027686171017 0.645183299051288 -0.333434855362184 -0.941919424447836 -0.0401122808807577 --0.505149445294128 0.741322735605485 0.441887587055162 --0.999500799132665 -0.0314197368592925 -0.00330948165991781 -0.776111981043863 0.0108191592568453 0.630502290775493 -0.0187331073416219 -0.998116739916231 0.0584127057096567 --0.924248200503259 -0.381518243834216 -0.0144600652883617 --0.833668647432129 0.372537060078126 0.407691948849902 --0.327038964825389 -0.94456751385317 -0.0289435184312302 --0.798817358866262 -0.601200023067952 -0.0211980998446345 --0.681605443146587 -0.73158108126747 0.0142527683087728 -0.0323649539061104 0.641918065563688 0.76608988171208 -0.398904267486258 0.314039701217539 0.861541903473331 -0.485792765926432 -0.763400140441741 0.425706018452967 -0.00796044579274392 -0.960244890544481 0.279045482826721 --0.850610221089367 -0.336111009401906 0.404340996112353 -0.00617195244471152 0.262128815129563 0.965013156014876 --0.352411840431892 0.432075475971554 0.830130518525467 -0.437362238008008 -0.357050462009041 0.825366125028013 -0.0153624677898509 -0.759240889070644 0.650628363158742 --0.537813631607848 -0.738082323148017 0.407419908587201 --0.675276990267964 -0.018724263094083 0.737326514094146 --0.0104337577463643 0.0621254364633444 0.99801381094829 --0.0226242476228692 -0.640266008940103 0.767820018764431 -0.00962247245744591 -0.290659693115491 0.956778109501787 --0.415449863861643 -0.337685415137283 0.844612319955672 -0.925221973108968 -0.352191192776736 -0.141158294856691 -0.828703937798552 -0.530549819142109 -0.178232075916343 -0.915361482823127 -0.343288705054251 0.210395391456231 -0.825440098762938 -0.514962921125903 0.23121815071423 -0.20834893061253 -0.386671724875428 0.898373920088109 -0.208096126459537 -0.52912878993139 0.822629154490819 --0.202190061095851 -0.373592842237581 0.90528866524601 --0.220277682479772 -0.526132398183942 0.821378379422392 --0.201833222562667 -0.367537125155257 -0.907843495269189 --0.206173769966577 -0.528295669186054 -0.823648020999886 -0.17089925162353 -0.343198393156208 -0.923584489220945 -0.177078143843663 -0.521420737117422 -0.834723754230588 --0.920474366587403 -0.340002292251821 0.192679479236961 --0.854558489257576 -0.504979009616762 0.12135068308124 --0.926645837736664 -0.323330839547885 -0.191793273090005 --0.848661743618652 -0.485221176921975 -0.210555585023535 -0.186637576946073 0.33205335502406 -0.924611801941206 -0.194929324713796 0.514275429885337 -0.835178627949061 --0.23181918899923 0.380596068946766 -0.895213100839129 --0.189098170360308 0.520350942220309 -0.832752531606371 -0.929183498074513 0.328950984420043 0.168550516923255 -0.843193814300153 0.502429957604862 0.191280760211621 -0.920022358080907 0.343510387944752 -0.188572198389089 -0.822112460168694 0.530376552302407 -0.20695848763264 --0.940597121642099 0.280851736142292 -0.190786155327003 --0.868370889155003 0.448457344154681 -0.211702643681836 --0.922389470452107 0.320271227394923 0.215925926423928 --0.853222922255462 0.496501669413268 0.159676977700884 --0.160393973989925 0.348935580007957 0.923318869141225 --0.215300627208089 0.489373248279447 0.845079560628599 -0.156394755511288 0.321133297103966 0.934031094739196 -0.190577605495245 0.474571923538157 0.859337922864453 -0.177719097084412 -0.969917827759185 -0.166359039208587 -0.177421220741897 -0.949950118087022 0.257131257487122 --0.192727167089408 -0.97452208726839 -0.114729858762886 --0.193038388275318 -0.95109982299084 0.241133380847326 -0.170905012709708 0.974483366320736 -0.145511667555905 --0.193038834127381 0.965590740798615 -0.174271425663314 -0.175567352671254 0.981901641549496 0.071030071085505 --0.177336902493926 0.964234106271959 0.196987845604183 -0.197812000279983 0.158664933984097 -0.967313729494756 --0.987383639689578 0.117217447287451 -0.106459467050963 -0.975379135310242 -0.181557814493113 -0.125189066606986 --0.22379956798744 -0.205292541013913 -0.952768978279985 -0.979283771110168 0.144088698346981 0.142273478374996 --0.190950919699202 0.192245152342718 0.962590020552236 -0.211287425807566 -0.133731586387258 0.96823214494147 --0.976780561391666 -0.188620849146435 0.101596801891883 -0.979125465676402 0.13573176517679 -0.151295110251331 -0.191403201292077 0.150965435925519 0.96983207396485 --0.228797711478784 0.176150708614813 -0.957404060507668 --0.967467604353168 0.182861901453797 0.174836951254142 -0.205897175651088 -0.164594081388709 -0.964632127513236 --0.222691326411275 -0.194350182117453 0.95532014521421 -0.972982054851382 -0.183650016121332 0.139923523811463 --0.977143711924299 -0.18979539110488 -0.0957490248626445 -0.206494949655555 0.63200329803964 -0.746948235846212 --0.755870012748045 0.606747457293368 -0.246004160323158 -0.729645925680946 -0.652586031620088 -0.204323993871353 --0.223609112647242 -0.650668545936682 -0.725692364621371 -0.723437587635327 0.671256403313887 0.16140910075483 --0.195609422742983 0.630553903590434 0.751091691074414 -0.200953278347717 -0.645443512832303 0.736899214047621 --0.747146139219564 -0.637447883013348 0.188236136517677 -0.267186114280672 -0.874163108208759 -0.405524895145042 -0.435273303945089 -0.872025595132082 -0.223849307140461 -0.469324794028913 0.846016621958175 -0.25296267131772 -0.282881884547712 0.880055602948958 -0.381418372804562 --0.203304424812984 0.626875646010903 -0.752126475594281 -0.739952744710592 0.651062776770445 -0.169077486080254 -0.716365540526254 -0.657382618150266 0.233812971625676 --0.196662264970255 -0.626125160586537 0.754513907636733 --0.745439302742624 0.654634856927303 0.12559239635567 -0.213549366171021 0.613257195941151 0.760468460775561 -0.202940977351341 -0.63391986015654 -0.746297910094082 --0.74174604521088 -0.633605466315707 -0.219902063357474 -0.306908988506562 -0.884052969603307 0.352501375471719 -0.419379061850744 -0.868601272965565 0.263918606929844 --0.426404455971003 -0.857824063300725 -0.286909596127955 --0.288643111662486 -0.865064334071774 -0.410303365824308 --0.452586437392487 0.836066492654812 -0.310094076931916 --0.28312553068495 0.880297129733856 -0.380679520406209 -0.315472548468849 0.863457014813575 0.393597579682345 -0.416733774447645 0.875949842856784 0.242991427901879 -0.603175842499272 -0.765528147642747 -0.223932039226096 -0.497461055172614 -0.867379951707728 0.0135837388832573 -0.586519353906217 -0.779561033082713 0.219726291536644 -0.28228549613215 -0.796656873190669 0.53446489601422 --0.00807235466110162 -0.887939058890965 0.459890274724366 --0.277426088644527 -0.800693957207419 0.530965113949046 --0.295186006797923 -0.882716301561015 0.365618862135338 --0.267960306836923 -0.768472222952846 -0.581074622152589 -0.0176016006711863 -0.890701740766229 -0.454247281389577 -0.293204319725017 -0.791435158557055 -0.536340951908726 --0.610594098151936 -0.762766365879119 0.212984314881603 --0.52627644183236 -0.849885300311258 -0.0269830147891806 --0.447889502405072 -0.853943196689511 0.264907550785242 --0.614137093690398 -0.761142021871975 -0.208562826731307 -0.270210778986037 0.777547372920634 -0.567808257939228 -0.00574445797033096 0.911203180724169 -0.411917181774182 --0.270211972383372 0.813546779973307 -0.514904968684272 -0.574980480476348 0.77810912772268 0.252870782072265 -0.523831759205988 0.85182108430079 -0.00106225598909506 -0.632657022874684 0.750319486501453 -0.191743994908676 --0.636791584414838 0.743510105752809 -0.204179334561281 --0.477642994716907 0.875600738946535 0.0719757983918707 --0.617428489355022 0.753169308755291 0.226975886124174 --0.462114001819959 0.844523324101903 0.270612276827597 --0.295101583418854 0.789440276611906 0.538237034332089 -0.00515144465232869 0.882562764881755 0.470166384019814 --0.274596811200646 0.870665356361923 0.408091201215612 -0.304445270634987 0.750212362832814 0.586936527948973 -0.401972948965307 0.0148301659438687 -0.915531438279545 -0.913054896078092 -0.0117998937525065 0.407665940759409 -0.893824332999384 -0.0373239116577721 -0.44686126186633 -0.432330259730304 -0.0126256070887671 0.901626940905809 --0.913139519120092 -0.00766598625870721 -0.407575086672147 --0.401154703588165 0.0321419551210659 0.91544622917465 --0.429807200164453 -0.00514724560090381 -0.902906017561915 --0.894351836283921 -0.021956311203087 0.446825148502109 -0.450731174967578 -0.50069976717195 0.73901363388391 --0.699646426972052 -0.580687739611866 0.416289113825598 --0.699781161985604 0.509219483621659 -0.501000841147168 --0.469198297726378 0.616562101844781 0.632221584556725 --0.66080443330473 -0.631671065859685 -0.405375339013739 -0.433025334935403 0.625009879471893 0.649501123837836 -0.482125253790825 0.480769853003436 -0.732403978757753 -0.767785486544235 0.514562025837211 0.381747780895105 -0.647538690323279 -0.648469967328854 -0.400225369019666 --0.466043397465583 -0.54704645429619 -0.695373085847233 -0.444305139130305 -0.637241233750685 -0.629695603724771 -0.673791265882919 -0.40490836766412 -0.618105608950017 -0.708863658776208 0.610124944628329 -0.353920704690594 -0.694570300742608 0.383826891976227 -0.608480907113932 --0.438609261902014 0.531749411860178 -0.724475312457316 --0.74038320954848 0.589532535967946 0.322930475573139 -0.739813897611508 -0.518826479618207 0.428362557826717 --0.472872642655859 -0.536339659035706 0.699093151141625 --0.695175714416567 -0.394293917806116 0.601051605493672 -0.646317108262769 -0.360355732528689 0.672620206060273 -0.605487766792538 0.212214215443413 -0.767039562883377 -0.589125712769541 -0.186547577702619 -0.786213009182031 -0.806799604282791 0.293393029960157 -0.512830311604073 -0.848546951768374 0.180349031388731 0.497435722000087 -0.83878100756312 -0.197207141655251 0.50749952180427 -0.580618902725186 -0.201824085024162 0.788764051223407 -0.598421322168502 0.263085823136023 0.756754762680053 -0.655152891723914 0.378308248218883 0.653955317889039 --0.845063333922377 0.157849609818671 -0.510834084943528 --0.841652672602827 -0.177179632067935 -0.510125628331679 --0.660726367348012 0.388301108799519 -0.642388446655265 --0.565004948629405 0.191006259742131 -0.802674290583425 --0.610812997189165 -0.260802986730832 -0.747588981043104 --0.654519281856502 -0.381618559913575 -0.652665139568169 --0.578297663197854 0.175209745496128 0.79678940619406 --0.574037695985489 -0.215202928415617 0.790043304628939 --0.662063060933045 0.385199169346151 0.642879540258518 --0.784997611985174 0.274549175671579 0.555339084988289 --0.828515885657205 -0.221189679697222 0.514428374809456 -0.813674296418654 -0.262030986761835 -0.518916083123493 --0.429108767012894 -0.189309841737949 -0.883191626938246 --0.285684116628288 -0.521057245030959 -0.80429095040729 -0.315381494225758 -0.465310996442978 0.827055130985336 --0.812083198644774 -0.492827282485322 0.312477436172606 --0.294329389095334 0.517043435890444 -0.803763831058211 -0.575309497605165 0.54539694711725 0.609558161327101 -0.294475543441729 0.486968774334179 0.822280710668909 -0.921729374105888 -0.168082381470347 0.349518631763207 --0.925957646763895 -0.160660301333005 -0.341746549324287 -0.911988021838257 0.161843495590616 -0.376941017877537 -0.443043687766642 0.168192657491721 0.880581353820308 --0.402328747451321 -0.175528211982005 0.898510670928649 --0.908787238731364 0.174603124727962 0.37897163951179 -0.72344688293262 0.226679193646753 -0.652105168468042 --0.219250017723182 0.0196979753139578 -0.975469845508776 -0.746447184456568 -0.438034241477687 -0.500941717278496 -0.406828456357159 -0.17149123805377 -0.897263262576172 -0.586268128106964 0.518257990941431 -0.622654267464143 -0.524696985085682 -0.364972250980917 0.769082784787124 -0.863137197530387 -0.0297475809781844 0.504092511018897 -0.74600759750462 -0.371192506093878 0.552891298434992 -0.715543445554296 0.218334536344371 0.663571855765127 --0.859314170875816 -0.0116365472450457 -0.511315701402004 --0.705443121438902 0.206056344343499 -0.678152479439788 --0.631380896021983 -0.020630017984072 -0.775198404601335 --0.75070031022435 -0.360742909965108 -0.553456048064316 --0.550800897886016 -0.021593098209439 0.834357302956998 --0.692013285181916 0.211304699857063 0.690266569486057 --0.812549692529643 0.00337595786275401 0.582882149390845 --0.590697375456045 -0.383232354198027 0.710077160120771 --0.545485813958299 0.342739212152678 0.7648366225693 -0.55857700116533 -0.365556570328765 -0.744553643237757 -0.908897517587682 -0.200927556929265 -0.365422248076641 -0.587780751888897 0.380396817089519 -0.714011238887096 --0.45190918921637 0.207511484959062 -0.867592685718297 --0.532774472974836 0.370038989672724 -0.761066690289606 -0.547144419060879 0.416152375469806 0.726257657502743 --0.758335489569539 0.363248392983053 -0.541274320704906 -0.413587609166218 0.212824526552783 -0.885240651146204 -0.203637767710719 -0.000299686740638808 -0.97904625516349 -0.928241020374605 0.162689222475059 0.334515806778054 -0.978076651003227 -0.00610035955222228 0.208155831952038 -0.971026516395835 -0.017169576950003 -0.238354169427612 -0.446530960876881 -0.217971847096773 0.86781240763865 -0.205466569717462 -0.00640623180802021 0.978643167310006 --0.928883500824529 0.136659794503561 -0.34423762499502 --0.976307940502751 -0.0157235842152086 -0.215813748891733 --0.435898412921971 0.248490732580447 0.865011519827187 --0.219394111258765 -0.0361681460090895 0.974965686144514 --0.924974158429857 -0.168361919440355 0.340700851656314 --0.972218476592509 0.00317831142045516 0.234053694926304 --0.583873591577952 -0.554233184586895 -0.593226100370282 -0.598515509177018 -0.580503843889431 -0.552081943649827 -0.761765248761627 0.359899150274158 0.538689435028269 -0.754992224368292 0.42138808186088 -0.502413003025426 -0.565687471680922 0.0157971292347002 -0.824468395447144 --0.600518330562032 -0.54516043817838 0.584959683486091 --0.573854921655917 0.513585638532249 -0.637903065351393 -0.60948816463208 -0.599402664933513 0.518884016369767 -0.716172175975181 -0.212931745237596 0.664648392933471 -0.634985448231805 0.0104531713432973 0.772453371889024 --0.536416167878567 -0.401144550379734 -0.742523228282533 --0.710257801285214 -0.221957785943889 -0.668033380133344 --0.755860010932317 0.406266177172906 0.513442730164437 --0.76339784220443 -0.412772956103472 0.496832186182841 --0.701809741713215 -0.239165758928034 0.671016263731966 --0.600513555691652 0.567047091914893 0.563773948477076 -0.708960661017883 -0.24091449222093 -0.662823497295485 -0.805342481334485 -0.026831723788042 -0.592202284997768 --0.151564486534186 -0.910648449416682 0.384379510375647 -0.0943673345448938 -0.989278505452863 0.111457816324574 -0.0710040324236531 -0.997458770115767 -0.00586764848319204 -0.110176169729192 -0.959657722823099 0.258685652191591 --0.0803487163187198 -0.993710831925865 -0.077992732348212 --0.107812770281472 -0.971561144486248 -0.210820656219468 --0.0877793489931485 -0.993554661564119 0.0717211292057545 -0.0716524493817951 0.995842384177468 -0.0562483099597341 -0.0905678248403751 0.972383018322777 -0.215101684747396 --0.0943966590421891 0.993716039431241 0.0601473502222724 --0.0676406259995983 0.99241258726236 -0.102674253625785 -0.0944576059066303 0.234952048822645 0.967406478911749 -0.117029024133638 0.05893502628946 0.991378267961624 --0.094541607121112 0.968564662496565 0.230096456048051 -0.312952695149127 -0.918898040074427 -0.240181186911622 -0.136992012761134 0.93591835947626 -0.324484225864554 -0.307844828685562 0.929479366230114 0.203223200457089 -0.149990058950367 -0.908523222599479 0.389985302560909 --0.148060939232232 0.893429980048645 -0.42410002242861 --0.187160120597947 -0.980808700932348 0.0546386441373017 --0.142009170351049 0.9325796400572 0.331856310000262 -0.153119163985281 0.912889996588215 0.378399756540115 -0.0910724389424852 -0.722124944476411 0.685741478569006 -0.139793421224385 -0.810372865226073 0.568993513748326 --0.100931456174854 0.715755181608311 0.691019074378759 -0.126290422770669 0.991979025404196 -0.00532374628871986 --0.0915642261521362 -0.10122357055329 0.990641096085562 --0.279079201404859 0.935371340368355 -0.217244689142756 --0.31742286342979 -0.920135322053706 0.229333196204027 -0.298039532317584 0.607963558825796 0.735902675844971 -0.316417387429291 0.594542387605788 -0.739188329367036 --0.279397293706135 -0.92681091254989 -0.250915692311437 -0.147122216658248 -0.923610211847529 -0.35397631267717 --0.170861658491118 -0.787040735292902 0.592767386625878 --0.0971715927709747 -0.733335009239946 0.672887394577577 -0.312290499157789 -0.932510274967211 0.181381452239073 -0.158755868215184 -0.815215670795365 -0.556973953068639 -0.100778944306587 -0.725220682573558 -0.68110099541257 --0.290779945080322 0.628077236917868 -0.721779750342652 --0.293233346198836 -0.594464728136611 0.74874955203893 -0.113896965384031 -0.439906212882609 0.890791785516452 --0.0830642540780588 -0.57876535924652 -0.81125272796503 --0.116508040547876 -0.434936275748161 -0.892892105758593 -0.137072182639773 0.792497686291129 0.594271515361098 -0.108835692488614 0.703072021319383 0.702740723793919 -0.101570411600099 -0.411758336006028 -0.905614997787103 -0.107403943900096 -0.583797767138543 -0.804763667121446 -0.0650583466879143 0.38580371020843 -0.92028414563962 -0.105482307759223 0.535438500173085 -0.837961273139866 --0.0712628586462657 0.323572838182521 -0.943515884004117 --0.113625893316683 0.425687326774429 0.897707890235809 --0.102832646897893 0.594616330248798 0.797406337154042 -0.101929828959828 0.413418314640936 0.904817996664339 -0.135141352622553 0.591778663708341 0.794691655921287 -0.104027247160934 -0.973196690778342 -0.205101274755186 --0.0919507911542678 -0.960778076820821 0.261630539323277 --0.0893888813966803 0.961328597299003 -0.260493677270257 -0.0899506951735484 0.951010238143891 0.295784379883885 -0.081669162538256 0.989403136420768 0.120048246680434 -0.106944066522221 0.132399914399279 -0.985410183275348 -0.111009908847689 0.267056281382487 -0.957265763887848 --0.0970907126413143 -0.129766391338622 -0.986779649768758 --0.117676221655445 -0.280055097304336 -0.952744167828257 -0.127949880303692 -0.0861101038981959 0.988035362796754 -0.115813815414919 -0.265127921767708 0.957232649494455 --0.113491878280956 0.0897244024601027 0.989479219169073 --0.104733075946245 0.265196337596827 0.958489376742418 --0.111179493387633 0.258954928435887 -0.959469366519241 --0.0850273308711731 0.144552485914106 -0.985837173077266 -0.109730232629608 -0.248925624787357 -0.962286500669773 --0.077774817292019 -0.322763186970783 0.943278857460325 -0.148199107568217 0.618962883110133 -0.771311852526574 -0.108016836253709 0.705782258858076 -0.700145532133806 -0.0949684121890556 -0.601999375002108 0.792828955817938 -0.340602420397268 0.916642922956442 -0.209178734610842 --0.103385676827001 0.700756878786509 -0.705869108730799 --0.138617931599754 0.613353990799904 -0.777548680796796 --0.105365413338962 -0.639991575803799 0.761123454225449 --0.497369288232657 0.856485193700655 -0.13804674604818 --0.103234507372396 -0.695891199495009 -0.710688451399751 -0.156582771463397 0.76243692092982 -0.627831010132422 -0.155740195637227 0.873311590924767 -0.461597071718756 --0.125234189143096 -0.445796015202743 0.886330813353021 -0.102403319752409 0.010296582602892 -0.994689670445204 --0.0777505738841875 -0.0127610356090503 -0.996891169702523 -0.310577413392635 -0.593806387780575 0.742250391796007 --0.324883613194028 0.629152767110994 0.706128482299484 --0.141898148531142 -0.915612395661287 -0.376189920591758 --0.288797930480302 0.92160762724287 0.259297390573183 --0.316175072993006 -0.598434815866003 -0.736144750967695 -0.296712066024054 -0.60748216567624 -0.736836052498141 --0.141977708671216 -0.811584011271018 -0.566721909660917 -0.07423388193595 -0.127733704524958 -0.989026506975951 --0.0816768761364163 0.91643753806662 -0.391753910927496 --0.0554935430742321 -0.823772042858705 0.564198624671724 -0.0928635352044403 0.875863975116966 0.473538447141982 -0.068184879226668 -0.800580739990171 0.595332932905307 -0.0695938962191385 0.749427385652918 0.658418774977197 --0.0967449375054242 -0.900802973718851 0.423313618498562 -0.101977751447671 -0.909141805917254 0.403809008001545 --0.0833436506196773 -0.755142396455026 -0.65024133748751 -0.0887021776068658 0.898477915219078 -0.429964370095219 --0.0858498815963245 0.844852651872531 -0.528066089096667 --0.0862377759198652 0.919670623893084 0.383104410771398 --0.0792103704032154 -0.943062886682265 -0.323045057202704 --0.0852321046500217 -0.866438060749873 -0.49195586714758 -0.0929910217867026 -0.906858395228451 -0.411048076106365 --0.0699016133536244 0.744644994220639 -0.663790326106599 -0.0553303335734015 -0.821508830189889 -0.567504886416581 --0.0425192289263111 -0.13779617690984 -0.989547537413208 -0.0447519746658523 0.24589084033415 -0.968263887276228 -0.052264357148572 -0.185843387994122 0.981188397867969 --0.0482314618142024 0.188872804713028 0.980816389407875 -0.0525235433578231 0.778120024683219 -0.625915732810836 --0.0609209768478945 0.786992069134778 0.613947976378177 -0.224000501219275 -0.875059032991117 0.429063473432737 -0.29429373862035 0.260942459882929 -0.91940210356465 --0.289236553245684 0.295469309524632 0.910516393809356 -0.313454551329661 -0.250875284953749 0.915864529092647 --0.0655957917727291 0.671658228147815 0.73795150021058 --0.457770882722902 0.396882372402176 0.795569105362643 --0.3089767793528 -0.0870724776114043 -0.947075357858804 -0.265886658305261 -0.418993952848519 -0.86818681884237 --0.769503848331409 -0.48059680090422 -0.420583573578167 -0.0616586495546003 -0.705542248165137 0.705980415443082 --0.0355716539153805 -0.759780003140275 -0.649206441947312 -0.033964262396535 -0.476568613990346 -0.87848095314536 --0.350890335191312 0.884829669642426 -0.30651660377507 --0.21400976156011 0.797922752790064 0.563488333984752 --0.251845693025195 -0.923710647429929 0.288673495023774 --0.0347169399828157 -0.99934755262131 -0.00996007771189584 --0.367744707870707 0.815693925600537 -0.446550388614179 --0.0292571880006647 0.720912921742434 -0.692407810625415 --0.010035074712675 -0.121913125713863 0.992490043806076 -0.269337228141682 0.538206785083715 -0.798618127784993 --0.0043331098550889 -0.473703495676597 0.880673732061287 --0.274997182001545 0.579838063111912 0.766918750884235 -0.153509798630469 -0.597914101306451 0.786723248152317 -0.137113865905157 -0.990113490644342 -0.0295814709001975 --0.183326647986317 -0.952739977829229 -0.242235164218703 -0.893615144248114 -0.448291148540726 0.022068532131961 -0.279409655559733 -0.264080739000915 -0.923142246714298 --0.0496599874132365 0.0043827619756607 0.998756565459062 -0.994749853203773 -0.102300699221529 -0.00270120155833627 -0.323892495720852 -0.0874214834429188 0.942046249102642 --0.187640854785066 0.0706117675123435 0.979696324329286 --0.155028597954234 -0.613488111889589 -0.774337439613048 -0.225191235222796 -0.792930959343378 -0.56617082342136 -0.37867964073559 -0.762792982115366 -0.524164665089045 --0.0315190776411661 0.857084396051534 -0.514210935112846 -0.202896894378939 0.924381464499074 -0.32303522771043 --0.336330107945057 0.71517412738022 -0.612705496968655 --0.233749083274759 0.717984607154263 -0.65563669052132 -0.397263445234435 0.801198268775952 -0.447507641488818 -0.9032775970048 0.429027567286563 -0.00499292072915605 -0.350134247503274 0.878183083631755 -0.32588415172932 -0.244396642238096 0.968874122576925 0.0394108597157837 -0.252585672480974 0.320376135015205 0.912994857690914 -0.200090183435401 -0.757470277928938 0.621452087088816 --0.0370016039804792 0.981828650448547 -0.186127328625477 -0.260955166132823 0.949471971259822 -0.174371376838571 --0.363047846906061 0.915838949754782 0.171567126714095 --0.0364378155334071 0.940397996043534 -0.338118166676178 -0.142002383080404 -0.697878956291631 0.701997354385892 -0.856811417204733 0.115032173783097 -0.502634851897829 --0.338864120628802 0.0834234093485643 -0.937129469456132 -0.0708126512221033 -0.632090633343777 -0.771652123476609 -0.350433319535822 -0.487795847404388 -0.799532175596542 -0.694578598012253 -0.715839205720125 -0.0716575378959797 --0.229149708443164 -0.708043005950191 0.667956220755095 --0.3959686985122 0.514955117751012 0.760282852957106 --0.518957637265045 -0.112736496611787 -0.847333141719349 --0.0339865652833582 -0.430369610854867 -0.902012700261404 --0.0613916363610178 -0.67941214754254 -0.731184108659748 --0.143829334493778 -0.311602598104442 0.939264043490242 -0.474574095083391 0.120269410739283 -0.871960261202428 --0.213563705820972 0.907421748671138 -0.361906498414476 -0.362125593414315 0.685794928913929 -0.631308458734927 --0.218507317569645 -0.883179920495354 0.415027445119402 -0.223002933529423 0.932297833213203 0.28476383517441 -0.0642012204051498 -0.710525127340044 -0.700736931178102 -0.370412265401335 -0.701936472807319 0.608341961221705 --0.392706645331401 -0.80108577781158 0.451711265412511 -0.249257904841122 -0.96138146033878 -0.116688408126464 --0.0456105600682379 -0.937559946191923 0.34482027798095 -0.0440544032342031 0.124867911131768 0.99119484175679 -0.0324893050163483 0.985974833893552 -0.163701166728087 --0.798522298742689 0.442619811844696 -0.407982647392334 -0.571486578618801 -0.465321082974298 0.675928531871679 --0.138280291972265 0.00116705600061672 -0.990392446877679 --0.727551158428881 0.682426541204333 -0.0704508887714353 -0.059044710537095 0.063037406109883 -0.996263021289322 --0.67447925655526 0.653799128061217 -0.342964185627387 --0.197724821718572 0.884260737852873 0.423069547909386 -0.0376029183692864 0.336996938104132 0.940754529215008 --0.0460875709859165 0.981345229517303 0.186648001072207 -0.466704095596977 -0.470864855654968 -0.748647831000687 -0.619650691225341 0.644350586941581 0.448157719973669 --0.50086724916426 0.0464034071606318 -0.864279308162883 -0.0418901304524357 0.834850310807835 0.548880839085078 --0.0554800226351767 0.504330613775197 0.861726522220091 --0.372818164036051 -0.676585316236457 -0.635010965588785 --0.0195029245286407 -0.284550837721513 -0.958462548400727 -0.0442521833661294 0.518806597371406 -0.853745546864658 -0.0567582145198074 -0.972161072964097 0.227335332268916 --0.495154030803471 -0.296686350664194 0.816578039815325 --0.688059029911164 0.484493790831351 0.540222674462648 -0.436619154864562 0.458801014404064 0.773863904564076 --0.37242574379025 0.822382561990531 0.430099973373829 --0.711153564219442 -0.694019262429842 -0.112240239995836 -0.49761882685598 0.314018788637837 -0.808559029101094 --0.0731755252982528 0.623808464026007 -0.778144165760329 -0.683671150262182 0.503264450822883 -0.52850605562957 -0.76846456849511 -0.543150486577757 -0.338304235707996 -0.220456320579764 -0.973963314011107 0.0528627815852869 --0.034561017239663 0.86796863159141 0.495414968143571 --0.159933241636601 0.55538520438501 0.816069012381814 --0.0495537092203952 -0.981116647613758 -0.186961369479476 -0.0387123104984408 -0.894566483655472 0.445255166546282 --0.0588169625804447 -0.510365772065005 0.857943671587653 --0.572017580487504 0.697810769307825 -0.431110215433646 --0.340478312240007 -0.698672831250567 0.629230318537269 --0.464138525742353 -0.0894653423405213 0.881232875828863 -0.141268367322708 -0.0807397451327189 -0.98667337146083 --0.491832784401042 -0.284251640482117 -0.822983303033265 -0.313065842774357 0.120824238267192 0.942014480533678 -0.685558538169556 -0.723128928229171 0.0842261473709411 --0.377679998808554 0.912116261644275 -0.159379245022817 -0.244162735411927 -0.712522998834336 -0.657795967430852 -0.0388423383678249 -0.986964030504345 -0.156183466604946 -0.0347303647242052 0.976698564704534 0.211786957743455 -0.262566638021458 0.685401590168884 -0.679178489641769 -0.0231303433992471 0.697122818334958 -0.716578511658672 --0.0231200588420912 -0.325602422630327 0.945224060874669 --0.0361626035095249 0.478469180312897 -0.877359395913737 -0.0803920695611113 0.676430353514137 -0.732105929491369 --0.864261447943213 0.104754875722642 0.492014802227976 --0.254308026015464 0.959713501368027 0.119488171782986 -0.717256680460352 0.695957687178515 -0.0344347497759049 -0.0503502527285484 -0.333425354185778 0.941431030525476 --0.534262647579739 0.460484517579267 0.708884639748159 --0.157671676811573 -0.707756410881009 -0.688636700436637 --0.136023633543982 0.393334417457833 -0.909277519330924 -0.678713033765172 -0.442664580736144 0.586000585971524 -0.0379615501722574 0.935968488736597 0.350031296887364 -0.0335452819356436 -0.606360673135567 -0.794481874012517 --0.349573919358831 0.884159840244463 0.309934592782076 --0.032074842413648 0.582595714329797 -0.812128954125324 -0.303720821728748 -0.0775407023142523 -0.949600495962922 --0.12955845488897 0.977927470879541 0.163928241819181 --0.0183164287261205 0.38746814101532 0.921701116488883 -0.232014283388051 0.833815428581261 0.500920356308044 -0.496056483834948 -0.613932896952985 0.614014953306695 --0.295281903589569 0.114410580001758 0.948535089807532 -0.0337415861959955 -0.454057620995073 0.890333186047377 -0.229076403643941 0.716849969169494 0.658521163665416 --0.0393593097405537 -0.180511883610226 0.982784973741579 -0.294801390452928 0.0985521220006488 -0.950462844847809 --0.472028377139998 -0.676651703134988 0.565094402572791 -0.055853796137231 0.515774371811915 0.854901836960879 -0.636408727986784 -0.684241985598488 0.356085433690403 -0.148180272182717 0.0512251924098807 -0.987632819725239 --0.0146770885290263 -0.769443761282642 0.638545911658301 -0.472025607161664 0.66775052858173 -0.575587576101572 --0.26293734505321 -0.957949438966438 0.114877434512854 --0.374203602649956 -0.915388725206207 -0.148442398017376 -0.0193271606429745 0.428728151262351 -0.903226789448058 --0.0383128724560451 0.999245551177164 0.00636020886542499 --0.0256149242264144 -0.853508289274743 -0.520449301850024 --0.305472673094744 -0.0917660749023171 0.94776866032243 -0.0402172164061413 -0.572608423944952 0.818841967861821 -0.0232769533682672 -0.658799261698267 0.751958586777031 --0.616170039446728 0.310765228744794 -0.723712273691288 -0.0211522142421918 0.106947475914337 -0.994039647714418 --0.492302819625624 -0.401702996022706 0.772186918287951 -0.356378651706183 0.482370769208879 -0.800195412146882 -0.208202771092264 0.732820509442376 -0.647785232195146 --0.28731537547007 -0.702895908579317 -0.650682116490801 -0.0275651892471077 -0.0387839133942975 -0.998867342745569 -0.0355833952698539 0.869913174852515 -0.49191959729115 --0.212974883266697 -0.781587665220705 -0.586312562267246 -0.469071183679784 -0.0602024123729678 -0.881106062960482 -0.0839538271462623 0.651069374760025 0.754360937586965 -0.24908594568594 -0.550854639881633 -0.796564722657624 --0.0255627119495296 0.758598502487467 0.651056725471413 --0.469969234066683 -0.671762791122633 -0.572593810212707 -0.0702554321442023 -0.0288605033571977 0.997111450942271 --0.217513052848477 0.929441675236619 0.298037320102507 --0.157504648384209 -0.135172554447972 -0.978223219036114 --0.694331093088008 -0.472876732708151 -0.542486800608527 --0.251286627552195 -0.966866307397966 -0.0449952712189418 --0.00835281953262917 -0.990853490228714 -0.134683300031708 -0.279984207607801 0.416365376103584 -0.86501370918174 --0.157870010838923 0.126364365344715 -0.979341159580636 --0.137259058741664 -0.976315408055429 0.167236882256617 --0.168730033817085 0.985432933700523 0.0212628517952396 --0.124663080987073 0.985910726021905 -0.11153096679295 --0.217355136220794 -0.888640832665782 -0.40382448573298 -0.012417948954997 0.452870930131885 0.891489604642271 --0.146663856836468 -0.155526627099621 0.976883402131937 --0.374111070751901 -0.918562320902831 0.127609440710593 -0.5491704009695 -0.484144115880726 -0.681187452730208 --0.0618262929845266 0.352254808644782 0.933859764248583 --0.00228750320134577 -0.188135746498327 -0.982140370934125 --0.25010943274773 0.702412411021228 0.666379828996912 --0.319496041052105 -0.250233814384117 -0.913950391372971 -0.221527906646693 -0.931293715242239 -0.289166738279217 --0.0719074955486769 0.473178550180294 -0.878026976654585 --0.166093082845252 0.705738941690129 -0.688727547011921 --0.109197494389759 -0.824349986927024 0.555448473102963 --0.625032406690348 0.678315970496178 0.386292550739332 --0.297702746774906 -0.450003076833532 0.84194436003992 -0.369052208664822 -0.817150733683286 0.442792440902601 -0.24257358140848 -0.932856067670573 0.266341162070113 --0.387168763881403 -0.474126694821552 0.790761800754271 --0.00468092657452546 -0.694459100294702 -0.719516953896347 --0.127953395215353 0.786313470045388 -0.604432837855493 --0.365981281793748 -0.785502776673801 -0.499042171779454 --0.146212752842214 -0.0175211708531735 0.989097992859269 -0.6834381189587 0.662818816585096 0.305914291812146 --0.991825291521668 0.119506409703853 0.0447304050691752 --0.166103402238841 0.721339659694257 0.672368020593525 --0.151306393476378 0.64517108808849 0.748906297468439 -0.203236350135968 -0.252543911429435 0.946000295339982 -0.214284204153929 0.846707706684188 -0.486999321654271 -0.390407062529839 0.911760123916994 -0.127576651318688 -0.0498460153132297 -0.941082051815175 -0.334484598313186 -0.475750508413303 -0.258662369976845 -0.840687356930295 --0.461518051505681 0.0649411774590119 0.884750660697485 --0.191150878570133 0.810396577553589 -0.553821928702083 -0.68204225990702 0.469351540108059 0.560827502445376 --0.153400916501419 0.947031942473737 -0.28213234261769 --0.0513043970733557 -0.318532127018495 -0.946522658417649 -0.0462057853202594 0.948756273234282 -0.312612474801525 --0.366961061699976 0.728424060588728 0.578565438953499 -0.0198487693603681 -0.0708315971842173 0.99729078567648 --0.134145644544436 -0.989797879550636 -0.0480114953612499 --0.245691125070062 0.96823526271639 -0.0464364845173604 --0.130492241191391 0.827983534601307 0.545357718766293 -0.171328729601487 -0.720177783169292 -0.672302333063411 --0.0161293521701194 0.563666982032793 0.825844644811974 -0.0325470205968244 0.999149778500671 0.0253063543863889 --0.0231524572582408 0.705869848787737 0.70796307834186 --0.0717796510385237 -0.698529710147188 0.711971857406227 --0.00986374309122692 0.230182405299198 0.973097511487367 -0.145623447943874 -0.980855225073691 0.129293614902582 -0.109226111009333 -0.84127659132515 -0.529455714448445 -0.20293738594071 -0.883182229285875 -0.422854073246532 -0.154094608404136 -0.647003059498595 -0.746754238461512 -0.0224002464164393 -0.188832335407806 -0.981753827629369 --0.148523420695098 -0.687588534421866 0.71074805721621 --0.0356604944919764 -0.942495469892872 -0.332311026545918 -0.493349773402508 0.308489757057098 0.813289659884193 --0.421412565716089 -0.46847425294273 -0.776494252255826 -0.258762817390334 -0.6889459995958 0.677048900728124 --0.00870630166933427 0.158715998550112 -0.987285891783876 -0.174880257328661 0.7082244052352 0.683984712859804 -0.510428609209994 0.103558380610912 0.853661699214154 -0.383822203690377 -0.915742379685647 0.118728303289197 -0.156750401630122 0.693235407467616 -0.703458585434853 -0.506557504861657 -0.0613429766262837 0.860021240137103 -0.147757958330027 0.966387346135796 0.210387934489494 -0.103930592811111 0.782087884837916 -0.614440373240305 --0.299058550657506 -0.374511936351002 -0.877670093377492 -0.128281161198353 0.40317357590463 -0.906087750371826 --0.139313280934882 -0.586921828641402 0.797567913609488 --0.210136550918752 -0.0820242904427641 -0.974225151464143 -0.250472813703324 -0.58478949580157 0.771546897599676 --0.0110483790706377 0.447755955837574 -0.894087544556959 -0.358283445229652 -0.851758339868103 -0.382283537887133 -0.0190747932907464 0.749077965978164 0.662207182947249 --0.0414198612213897 0.0606048168321622 -0.997302086267316 --0.0353891245658422 -0.982413283850784 0.183335074592894 -0.0114657156635506 0.258293423475662 -0.965998470368119 -0.0405496394960869 0.606752125487098 -0.793856148778622 -0.329047626624524 -0.704614354332008 -0.62868614672351 --0.333898069636535 0.244717050146052 -0.91028876982022 -0.0547430047069741 -0.31408503077954 -0.947815275713505 --0.031155345228946 0.282502945198474 -0.958760361309255 --0.311433982997564 -0.267518488756561 0.911834816404637 --0.16202916503948 0.290238156872499 -0.943137509577402 -0.000506380042393702 0.996499024386653 -0.0836028586574711 -0.00811394151062261 0.0921798053013889 0.99570931875109 +350 +0.409099976185 0.374343915351677 -0.832168157600739 +-0.00676898942519239 0.359970457069891 -0.932939146364357 +-0.0184156563858816 0.56187292472942 -0.827018548797961 +-0.0188588823146625 -0.0242039639643836 -0.999529144490671 +0.637050846706389 0.0355753343765049 -0.770000398892542 +0.425976928655917 0.803677673983853 -0.415506741934203 +0.00126957702871189 0.757755861195981 -0.652536928454861 +-0.414511440679194 0.345812466414258 -0.841780258510822 +0.379765507427127 -0.334119193705169 -0.862636959425241 +0.0244790756235797 -0.265021521239553 -0.963931723794008 +0.851748671565588 0.359982017809195 -0.380706116762362 +0.00707604190340824 0.948462193090084 -0.316811297004589 +-0.425186643220739 0.819675095498102 -0.383860725064257 +-0.34340333312757 -0.375475047784262 -0.860867376131934 +0.000909467010270103 -0.58439091971785 -0.811471765264253 +0.634593699216233 0.772826515160367 0.00547853813886981 +0.81299121221129 0.582095286807476 -0.0145039975089416 +0.302110912015656 0.953236248721387 -0.0083457153465995 +0.837274130837251 -0.354500383020531 -0.416294977472733 +0.981088624657074 0.193521979510509 -0.00378866926825313 +-0.0084528661032143 0.997384893201429 -0.0717769034454351 +-0.766230931016361 0.0128531127803461 -0.642436734508275 +0.999611756765236 -0.0278478580216519 -0.000912436476977347 +0.402890550943227 -0.822370987153248 -0.401727723027993 +-0.31340756936981 0.949618632958265 0.000383927315592365 +0.0119909301049933 -0.796270341159199 -0.604822090689013 +0.970186672037849 -0.242344084912933 0.00267692133534165 +-0.835448303693298 0.357014523312791 -0.41781187393339 +0.835766814830597 0.371919742504771 0.403942491405774 +-0.676111741819579 0.736791324532634 -0.00338476988033963 +0.00701682295815462 0.9641092253798 0.265413198114066 +0.796656776344593 -0.604294119507667 0.0129072782837788 +0.400847588210647 0.831584393787815 0.384432838132047 +-0.413461425259074 -0.82511141063141 -0.385020531749385 +-0.800820216027451 0.598148792368702 -0.0300832808983731 +-0.00859585533153707 -0.962277908499738 -0.271932598421905 +0.666660914099349 -0.74516736543171 0.0169947964914459 +-0.831394155331905 -0.35592347925581 -0.426734385062169 +0.816907081889058 -0.404825690574061 0.410827189716964 +-0.965142241501211 0.261643103009923 -0.00658333633936184 +0.00991873146858048 0.790509483934643 0.612369475541882 +0.305353473091908 -0.952232993869882 -0.00340321264544506 +-0.42301659362051 0.814619863454509 0.396801511573555 +-0.997583269412733 -0.069355968469664 0.00416776024232093 +0.76402021042553 -0.0115411910653604 0.645089078321841 +-0.00594037979659785 -0.996231844793772 0.0865264312604514 +-0.967855553123514 -0.251289692414583 -0.0104459932108612 +-0.840294186281479 0.400992830688455 0.364843021363994 +-0.315484718204731 -0.948905667505886 -0.00688670853817552 +-0.803033482803576 -0.595342889983053 -0.0265342955999395 +-0.641414957281078 -0.766368321539261 0.0355871931628301 +-0.015942197025074 0.532619297215047 0.846204780527836 +0.430611645583323 0.315430034432395 0.845622554137483 +0.443061760292844 -0.807964133083718 0.388445924443136 +-0.011104011611261 -0.961321595361929 0.275204453483101 +-0.84342790605703 -0.372896693797687 0.386752405343533 +-0.0167357312337635 0.345176205983856 0.938388673270656 +-0.444135314137227 0.335126592501904 0.830923576350009 +0.418552979141691 -0.319201985705547 0.850249078784124 +0.0280892267794737 -0.772800340835172 0.63402730898911 +-0.445042871068191 -0.777829657773276 0.443754286063458 +-0.633305133442798 -0.0464746867113823 0.772505476647305 +0.0033634290681748 0.0155931802985888 0.999872761941778 +-0.0330996375900012 -0.536848401249408 0.843029185774351 +-0.0222030122336391 -0.339601457115166 0.940307330915275 +-0.429397410800457 -0.350481264312601 0.832334516263566 +0.933307951919963 -0.323000000294005 -0.15686703507441 +0.85126550262143 -0.495018093715291 -0.174080817269346 +0.921261366146006 -0.337947841223825 0.192532469622532 +0.813833381207743 -0.546211371980552 0.198313803733113 +0.161424364512197 -0.298745124257481 0.940581482527811 +0.156024443411607 -0.439417638478773 0.884629025101391 +-0.229276201593984 -0.322757135132016 0.918292031493255 +-0.215461733821149 -0.480422940952023 0.850158831669585 +-0.14332230799843 -0.300356556919995 -0.942997696044465 +-0.168938927496285 -0.503220250106972 -0.847483934159629 +0.201895666757738 -0.271407392643362 -0.941050565571787 +0.16125225814748 -0.447903949201145 -0.879420128000466 +-0.929481181604424 -0.332837923855499 0.159008331501233 +-0.839320706945052 -0.522800109690457 0.149066415402344 +-0.924926636339964 -0.321979864683051 -0.202088307745708 +-0.826657298149905 -0.513633263355121 -0.229822936607006 +0.191375088462794 0.323034659736432 -0.926835575560641 +0.186929692824834 0.500027787937474 -0.845594170527902 +-0.201586746688038 0.309512833151904 -0.929281760110471 +-0.195228311733031 0.489361115694824 -0.849948001199949 +0.933199558489084 0.305807258552501 0.188733952039328 +0.852193652412113 0.497972855186648 0.160589583366294 +0.946411031059704 0.275972867509313 -0.1677651235722 +0.871248145461172 0.466961043737599 -0.151241702787164 +-0.925068471537101 0.334167824422927 -0.180499828499808 +-0.844032269178657 0.493520733766675 -0.209873328290018 +-0.926078222149039 0.330196647665629 0.182617908025625 +-0.83541887249827 0.522773037396067 0.169657475064939 +-0.232987942701527 0.293573510074266 0.927109061943839 +-0.227729952984235 0.459485588058864 0.858494066886894 +0.220158441487186 0.316296416893362 0.922760444157829 +0.148574490057549 0.488333864335461 0.859916076048899 +0.175218504313738 -0.96823899004013 -0.178358442222747 +0.173523028631816 -0.971899227037106 0.159064927055331 +-0.208812345891564 -0.963548433115724 -0.167247783971853 +-0.194752634387836 -0.961125383970249 0.195727891949613 +0.178028736497171 0.967179551276115 -0.181299433464513 +-0.183038262812713 0.966997461895797 -0.177236855742791 +0.191097898429518 0.966336154777426 0.172267318971998 +-0.17335345601321 0.970077765803702 0.169993257459151 +0.08730365059498 0.140983885131143 -0.986154965878141 +-0.975870504347966 0.163990656210063 -0.144165957907683 +0.979653058608685 -0.129155265012291 -0.153619016655668 +-0.144189662017749 -0.128082874873247 -0.981225824431569 +0.983725802209736 0.111565507333623 0.140842762115069 +-0.151087364654085 0.138340417588153 0.978792387129885 +0.0890974937511422 -0.14812954221368 0.984946331193142 +-0.977670624285554 -0.145234090671077 0.151878929796204 +0.9819314801572 0.0987839847281654 -0.161407226100679 +0.140708389956481 0.15611651587368 0.977664964324342 +-0.114790619384211 0.151542235024516 -0.981762733406175 +-0.972818110261153 0.157050514508289 0.170176556083969 +0.137965697911204 -0.116033201824583 -0.983616674459217 +-0.17669595304823 -0.188639991891094 0.966019406448807 +0.97218719892853 -0.163752613897543 0.167442920666182 +-0.97799822652595 -0.15249480445914 -0.142354499490057 +0.181566412908601 0.669683594327887 -0.720109381407843 +-0.734740795197443 0.647223174267385 -0.203120965347943 +0.734077342895589 -0.657869309712285 -0.168340209059017 +-0.195236381046176 -0.629244221723334 -0.75228615894737 +0.722415899879567 0.673144343439039 0.158088457824159 +-0.196228631016609 0.614599425268782 0.764043107964878 +0.124570922007776 -0.598498162342447 0.791379829830687 +-0.723715472930607 -0.669907257494902 0.165711136006265 +0.21286388208809 -0.913449764667328 -0.346840734533287 +0.367496484773383 -0.906131823737612 -0.209455130491371 +0.348933492844354 0.909835411791181 -0.224599512515524 +0.225634214477486 0.904385973232103 -0.362181187637002 +-0.197432209077429 0.660860426597232 -0.724074595174096 +0.763083578228629 0.613686626300025 -0.202712055236698 +0.715257477354791 -0.674992577983088 0.181084954526339 +-0.212552156332393 -0.639218769038958 0.739067619468455 +-0.72182938545385 0.662549530999627 0.199976141745689 +0.204258998708362 0.62432357647084 0.753988284596861 +0.195117031009769 -0.612839308614537 -0.76573972472818 +-0.719031703818568 -0.659986261451736 -0.217741919709383 +0.215318651139985 -0.911639107581058 0.350074300684968 +0.358216963275817 -0.913630264735549 0.192250738830059 +-0.387912898025195 -0.897941068644122 -0.207907240826161 +-0.219566474860783 -0.9143580576996 -0.340205681076938 +-0.382751464402236 0.898394828571857 -0.215378848760242 +-0.214332883356453 0.908472220437028 -0.358803065491816 +0.211037421577868 0.918183706650338 0.335263907296345 +0.369403168302531 0.905924755044336 0.206982215288929 +0.585297860176727 -0.782789159695283 -0.211346980901307 +0.50369951446883 -0.863875692003519 -0.00236387167732843 +0.573341724896987 -0.789208079833845 0.220067883202258 +0.211539608996433 -0.828892271105026 0.517869285368411 +-0.0157572225525736 -0.891007632061369 0.453714788766932 +-0.210108082693641 -0.784568163537489 0.583358714986083 +-0.237060679150787 -0.894301140345898 0.379509821712948 +-0.213402353201275 -0.824610166729428 -0.523906011202986 +0.0227314346274975 -0.899208189800484 -0.436930101132334 +0.214323824434487 -0.81867575451528 -0.532761961150204 +-0.558092307314912 -0.796115089780801 0.233952431787371 +-0.472698579416846 -0.881223662357106 -0.000953896862543137 +-0.368132666724736 -0.905125353380237 0.212665075549406 +-0.574107242887815 -0.794611294136036 -0.1974683896101 +0.225172942600514 0.801048077342269 -0.554634225149224 +-0.00766332132353331 0.875113293517254 -0.48385741393067 +-0.220604442986987 0.800420354710826 -0.557369657856432 +0.570433099758663 0.795305423303102 0.205171543749118 +0.457520824630092 0.889190346811301 -0.00390155961114712 +0.546984990591017 0.811130914296212 -0.207060522411048 +-0.600012354237745 0.769383979201763 -0.219165388028628 +-0.518735428336337 0.85490177003585 -0.00751791050006514 +-0.572935030441984 0.79324492419244 0.206174540463591 +-0.36456589833661 0.909660454920196 0.199021512717603 +-0.216883390751039 0.827659509385042 0.517630496919224 +0.0222157536584879 0.894205360876725 0.4471053934686 +-0.198699272599409 0.915452065975522 0.349951588036993 +0.225108625874263 0.834752187152047 0.502508599530271 +0.397602897150624 0.0199691175799429 -0.917340269758451 +0.904768252922954 -0.0165647107695091 0.425581976662392 +0.878659997643549 -0.0190436059790688 -0.477068076496795 +0.464355177178046 0.00935448299303468 0.885599662983156 +-0.912498086372697 0.00070185468810702 -0.409080370790586 +-0.416478546027379 -0.0165989625884009 0.908994001707332 +-0.476867568590918 0.00113956551783734 -0.878974415678077 +-0.891519275922422 0.00851222023684871 0.452902774075629 +0.423292835105036 -0.590679347679808 0.686965125732957 +-0.649440095113263 -0.667223224712759 0.364747489728421 +-0.639564051552707 0.659814281746599 -0.394465381959819 +-0.507444430386716 0.538314794640858 0.672842724520576 +-0.721714615064821 -0.528751741366957 -0.446709760810358 +0.416634378604236 0.565632370546229 0.711671143123927 +0.413187454392312 0.659999912485062 -0.62743624620555 +0.634352944919258 0.649075591262616 0.41987762276567 +0.666844299161362 -0.653162191910205 -0.358744800289912 +-0.477044752777183 -0.550744235868961 -0.684915389303577 +0.492052182598486 -0.523325341945905 -0.695712035311499 +0.673096134493098 -0.370751790433143 -0.639909918364349 +0.716365722949659 0.576176532831523 -0.393498099102215 +0.691577638563758 0.380921781821027 -0.613692892229388 +-0.38706664070851 0.627103831521279 -0.675958726655674 +-0.622598315764769 0.671932528755161 0.401096015945767 +0.696820120268325 -0.611569750158168 0.374732118560331 +-0.402957575791034 -0.653059966837741 0.641200336732992 +-0.682350749127822 -0.390564656560901 0.617945551169491 +0.617892689094507 -0.413032916614975 0.669038440267886 +0.527994488620273 0.224875893847039 -0.818933851024069 +0.501863080511222 -0.162360791210957 -0.849571905077575 +0.811922803151348 0.170591734055208 -0.558282922893845 +0.826779688087273 0.207778280558492 0.522746146321968 +0.815934701604228 -0.214191064220906 0.537003492284674 +0.577378601990646 -0.287821754531891 0.764063209153216 +0.545627465190432 0.220754324963174 0.808429463367038 +0.629342541864964 0.36712924398114 0.684940934105111 +-0.838429543875052 0.186259794613665 -0.512194483441541 +-0.842096393885583 -0.184222542011022 -0.506888270154177 +-0.646080537570303 0.372697284961295 -0.666090589000736 +-0.544628697845101 0.216080372775301 -0.810363408591995 +-0.553115248715364 -0.205171231322512 -0.807445532203966 +-0.637559637758989 -0.354822273701484 -0.683826631819744 +-0.53608087328504 0.171299343377108 0.826603794000802 +-0.526815038187043 -0.234407348479518 0.817018427282265 +-0.683732195240754 0.358325803662782 0.635698752256665 +-0.807148874691989 0.195661463988703 0.556980507372792 +-0.81361289390515 -0.254570203864913 0.522712225010535 +0.791473624955648 -0.247029141751424 -0.559058229637236 +0.338175949850729 0.480745803212814 0.809024412261968 +0.352845960045935 -0.121826874646541 -0.927716519790996 +0.38011638133728 0.162399230081241 0.91057016572479 +0.91163322696412 0.156631373412501 -0.379988779252623 +-0.925609682156197 -0.145124122754587 -0.349550719200255 +-0.362483645033635 -0.167777186502633 0.916764104212414 +-0.377997424333379 0.156876917275725 -0.912418533362512 +-0.901155436571974 0.17258313876512 0.397660583099149 +-0.365613680405477 -0.155485501631459 -0.917687798482019 +0.728916047078377 -0.437200245517923 -0.526818129557726 +0.555550851076301 0.422987151419767 -0.71585272340209 +0.504652454566774 -0.406584011612166 0.761587382774352 +0.509945926046591 0.0301997180754188 -0.859676177136863 +0.68607025198028 0.248651333251543 -0.683725181502002 +0.853416560213393 -0.00573258216299039 0.52119795879808 +0.73714982192369 -0.381241941949589 0.557911033890151 +0.695766041034713 0.217848165040144 0.684435382729096 +-0.854934309673121 0.0140006398395487 -0.518547305679847 +-0.696247327691613 0.231445649900076 -0.679464914344089 +-0.607972389671202 0.0119530615854352 -0.793868186613006 +-0.744669246641319 -0.352834173540516 -0.566547225823789 +-0.523296525270415 -0.0313885774856377 0.851572371465478 +-0.684065532958045 0.186497512168922 0.705175882013579 +-0.794562048111899 -0.0213115774195934 0.606808840054356 +-0.566240474631354 -0.410361445189101 0.71482529977021 +-0.74959920783105 0.366457831392727 -0.551189337188231 +-0.577429014646223 0.376860547643335 0.724259525774192 +0.538819531059558 -0.367227297215969 -0.758167280438963 +0.903226291417752 -0.181733095492132 -0.388787022024375 +-0.549080348196169 -0.641589178229129 -0.535606289735329 +0.515804320063131 0.405456129362041 0.754686180188138 +-0.747553173276141 -0.44228094453586 0.495531854904647 +0.326521517971109 0.180701852286506 -0.927755646106273 +0.200705995201958 0.00568599950651361 -0.979635020249686 +0.925317134044739 0.154780208925289 0.346166561597556 +0.970036374252315 -0.0173067959850486 0.242342541540183 +0.961973048405396 -0.0144096513867718 -0.272764030048943 +0.349551630380503 -0.1380587195213 0.926689509848078 +0.248131467428538 0.0139813531109563 0.968625467679302 +-0.919460565171674 0.166382349515495 -0.356243151322084 +-0.980640039416628 0.00497588558961509 -0.195755852161703 +-0.372075818045742 0.136985841740551 0.918038378712037 +-0.229059647261975 -0.0105605300920073 0.973355101286471 +-0.250722803698323 0.00221397981963236 -0.968056389885946 +-0.914254502787949 -0.172226985099232 0.36671047126526 +-0.967590842271158 0.00895503657133257 0.252364358166911 +0.904469764252152 -0.209627075079073 0.371471311069171 +0.724147391334604 0.400092353501059 0.561726503107403 +0.549284042035154 -0.636177520490794 -0.541816577438998 +0.600615107109978 0.497043828498283 0.62626585861201 +0.596584773932782 0.590911989615779 -0.543055824054851 +-0.61106089770987 -0.568713068103685 0.550608777135001 +0.530713725749711 -0.641190161658993 0.554272602509428 +0.686664612966292 -0.252546857262423 0.68169772933957 +0.617478535479478 -0.0061377827831401 0.786563783710276 +-0.532093123110521 0.386705844878501 -0.75321676685752 +-0.509327434523505 -0.398083693553237 -0.762964571502974 +-0.695109184406186 -0.185760763072112 -0.694489856410469 +-0.739326837359655 0.423371345184909 0.523595771216777 +-0.674353367361063 -0.258440862420523 0.691705035806544 +-0.523088091820135 0.662407618090643 -0.536278841360956 +-0.635610326181521 0.494685955106365 0.592693275710063 +0.660129054130686 -0.228893515658464 -0.715428116851746 +0.776646309765289 -0.0227918953630365 -0.629524454674891 +0.747352746922299 0.429389431154322 -0.507039039996589 +-0.165437694408415 -0.986202115079324 0.00597975600631719 +-0.000351790467931239 0.995301763330114 0.0968208456657542 +0.486840405763969 -0.145157161026973 0.861345353454793 +0.365528740818937 -0.506172410545428 -0.781139059603316 +-0.39962591147441 -0.512894476153907 0.759762059600936 +-0.451117982490508 -0.28768940917233 -0.844823869054236 +-0.385614120928669 0.507230623812022 -0.770726179656353 +0.33758573706832 0.716768670228339 0.610146329585893 +0.812797144171075 0.3120079613457 -0.491946983408015 +-0.400692175950409 0.508108890593405 0.762411395135241 +-0.76206063434664 0.502762058104531 -0.408036643586938 +0.191566145378229 -0.702439113237125 0.68547917848726 +0.899672811217054 -0.436375781387445 0.0128456286456049 +0.758399607597409 0.539366988822428 0.365941643660193 +0.926049925773517 0.377396201059541 0.0019085074512021 +-0.0132478508807923 -0.427119949907771 -0.904097916620663 +-0.780375357461643 -0.539696843789808 0.31581896439247 +-0.902500948761553 0.430650531496554 0.00567073242464512 +-0.0117302112518093 -0.993642750171552 -0.111966455581589 +0.131771136574139 -0.991251334627078 -0.00756036811254642 +0.701076810859431 0.707483956400789 -0.0892062593692605 +-0.706492751885707 -0.705829629410436 -0.0516964774359688 +-0.00664671600165877 0.981953685291258 -0.189004711870657 +-0.140956062628909 0.98999946535447 0.00569622734958889 +-0.0386394515141474 -0.693705914156682 0.719221174223012 +-0.759887635567738 0.554052390374704 0.339995191188565 +-0.902206882672117 -0.429624984376072 -0.038014650582634 +0.801556049548186 0.492368191804563 -0.339236588728 +0.141624405520956 0.989808639959008 0.0148789792437225 +0.365731729437078 0.524212391856574 -0.769052449646299 +0.156705113849284 0.735376693947132 0.659291001980816 +0.602897924801847 -0.442924531246989 -0.663575129046638 +-0.57124309421974 -0.471478740074821 -0.671854988047062 +-0.159129927524667 0.727971576739348 0.666884584936271 +0.633460435660565 0.711280529387038 -0.304643865796807 +-0.365157479220698 0.734773121170637 -0.571636664127089 +-0.821014384543827 0.312568176900091 0.477741054507014 +-0.662791696338262 -0.452635274984383 -0.596513600100501 +0.319527162134497 -0.520403443292349 0.791885502372497 +-0.0829403010173546 -0.712530660480124 -0.696721583089622 +-0.66783801606026 0.49854504713637 -0.552670987369963 +0.00170881947996397 0.685088973147729 0.728457396700298 +0.661372944882279 -0.498459153055063 0.560467929959753 +-0.550857833071762 0.491319051966469 -0.674656384330759 +-0.0612009805839106 -0.128445315098461 0.989826369119769 +0.109338669026245 -0.708304873183478 -0.697387454776831 +-0.337121238423381 0.695341964932503 0.634703728055612 +0.36521981034401 -0.735502118608164 0.570658500028859 +-0.504270911207413 0.668333099494954 0.546847068410825 +0.334914240054063 -0.692113652119366 -0.639383409511854 +-0.334650834623069 -0.700543612470209 -0.630275706269307 +0.557148614182785 -0.735633657019151 -0.38526425265632 +0.776621523581631 -0.538633422819983 -0.326700237114967 +-0.00912205680103684 0.683155675644869 -0.730215797496823 +-0.600529601006242 -0.713033006307068 -0.361867558965968 +-0.347153499087816 -0.535778228055189 -0.769692236165292 +0.00306681505088476 0.169221807009205 0.985573221368145 +-0.996380042511763 0.0835767023268314 0.015548173925845 +0.49990168980052 0.676390311980007 0.540919999994614 NormalAtVertices -678 +350 1 1 2 2 4 3 @@ -12460,1749 +7500,765 @@ NormalAtVertices 308 289 309 290 310 291 -311 292 -312 293 -313 294 -314 295 -315 296 -317 297 -318 298 -319 299 -320 300 -321 301 -322 302 -323 303 -324 304 -325 305 -326 306 -327 307 -328 308 -329 309 -330 310 -331 311 -332 312 -333 313 -336 314 -337 315 -339 316 -340 317 -342 318 -343 319 -344 320 -346 321 -347 322 -348 323 -349 324 -351 325 -352 326 -353 327 -355 328 -356 329 -357 330 -358 331 -359 332 -360 333 -361 334 -362 335 -364 336 -367 337 -368 338 -369 339 -370 340 -371 341 -372 342 -374 343 -376 344 -379 345 -380 346 -381 347 -384 348 -385 349 -386 350 -387 351 -388 352 -389 353 -390 354 -391 355 -392 356 -393 357 -394 358 -396 359 -397 360 -398 361 -399 362 -400 363 -401 364 -402 365 -403 366 -404 367 -405 368 -407 369 -409 370 -410 371 -411 372 -412 373 -417 374 -419 375 -421 376 -422 377 -425 378 -426 379 -429 380 -430 381 -431 382 -432 383 -433 384 -434 385 -435 386 -437 387 -438 388 -441 389 -442 390 -444 391 -445 392 -446 393 -447 394 -449 395 -450 396 -451 397 -453 398 -455 399 -456 400 -459 401 -460 402 -462 403 -463 404 -464 405 -465 406 -466 407 -467 408 -468 409 -469 410 -481 411 -498 412 -502 413 -503 414 -506 415 -518 416 -519 417 -527 418 -528 419 -561 420 -563 421 -570 422 -578 423 -580 424 -584 425 -590 426 -593 427 -594 428 -599 429 -609 430 -613 431 -614 432 -616 433 -619 434 -622 435 -627 436 -634 437 -637 438 -649 439 -661 440 -675 441 -680 442 -682 443 -688 444 -698 445 -699 446 -708 447 -709 448 -718 449 -719 450 -720 451 -722 452 -729 453 -735 454 -742 455 -743 456 -744 457 -747 458 -759 459 -773 460 -775 461 -778 462 -780 463 -790 464 -794 465 -796 466 -797 467 -798 468 -808 469 -821 470 -822 471 -826 472 -830 473 -831 474 -834 475 -836 476 -838 477 -839 478 -843 479 -844 480 -845 481 -859 482 -869 483 -873 484 -875 485 -883 486 -884 487 -885 488 -891 489 -906 490 -918 491 -922 492 -960 493 -961 494 -962 495 -967 496 -968 497 -970 498 -972 499 -988 500 -990 501 -994 502 -996 503 -1005 504 -1006 505 -1012 506 -1014 507 -1018 508 -1022 509 -1036 510 -1044 511 -1048 512 -1053 513 -1056 514 -1062 515 -1066 516 -1074 517 -1075 518 -1077 519 -1079 520 -1083 521 -1084 522 -1094 523 -1096 524 -1098 525 -1099 526 -1100 527 -1102 528 -1106 529 -1108 530 -1111 531 -1116 532 -1119 533 -1120 534 -1123 535 -1127 536 -1133 537 -1141 538 -1144 539 -1147 540 -1159 541 -1160 542 -1162 543 -1165 544 -1180 545 -1182 546 -1186 547 -1195 548 -1203 549 -1204 550 -1221 551 -1225 552 -1228 553 -1229 554 -1236 555 -1237 556 -1246 557 -1250 558 -1253 559 -1258 560 -1259 561 -1264 562 -1275 563 -1277 564 -1284 565 -1287 566 -1295 567 -1302 568 -1309 569 -1310 570 -1316 571 -1318 572 -1329 573 -1331 574 -1335 575 -1341 576 -1343 577 -1345 578 -1349 579 -1351 580 -1353 581 -1356 582 -1369 583 -1371 584 -1372 585 -1386 586 -1388 587 -1396 588 -1402 589 -1406 590 -1410 591 -1415 592 -1420 593 -1437 594 -1443 595 -1456 596 -1459 597 -1466 598 -1468 599 -1479 600 -1480 601 -1485 602 -1487 603 -1496 604 -1499 605 -1509 606 -1510 607 -1518 608 -1526 609 -1533 610 -1538 611 -1539 612 -1543 613 -1554 614 -1558 615 -1566 616 -1574 617 -1580 618 -1591 619 -1601 620 -1624 621 -1632 622 -1633 623 -1634 624 -1641 625 -1647 626 -1651 627 -1653 628 -1663 629 -1673 630 -1674 631 -1676 632 -1680 633 -1683 634 -1693 635 -1696 636 -1697 637 -1706 638 -1715 639 -1717 640 -1719 641 -1724 642 -1725 643 -1726 644 -1729 645 -1731 646 -1738 647 -1739 648 -1755 649 -1758 650 -1762 651 -1767 652 -1783 653 -1798 654 -1799 655 -1808 656 -1812 657 -1822 658 -1830 659 -1849 660 -1852 661 -1856 662 -1858 663 -1866 664 -1873 665 -1875 666 -1890 667 -1891 668 -1895 669 -1901 670 -1903 671 -1908 672 -1909 673 -1911 674 -1919 675 -1931 676 -1944 677 -1952 678 +330 292 +334 293 +361 294 +362 295 +375 296 +422 297 +454 298 +458 299 +473 300 +474 301 +492 302 +494 303 +496 304 +498 305 +506 306 +508 307 +509 308 +519 309 +523 310 +524 311 +525 312 +526 313 +528 314 +529 315 +556 316 +562 317 +570 318 +588 319 +623 320 +632 321 +640 322 +648 323 +651 324 +657 325 +661 326 +675 327 +684 328 +685 329 +686 330 +699 331 +705 332 +707 333 +710 334 +722 335 +723 336 +724 337 +731 338 +737 339 +741 340 +742 341 +796 342 +821 343 +825 344 +931 345 +939 346 +973 347 +1047 348 +1074 349 +1127 350 Triangles -1352 -2 1895 1762 3 -46 156 1084 3 -455 45 918 3 -84 466 1674 3 -317 1719 319 3 -106 286 130 3 -114 502 131 3 -89 88 55 3 -81 241 272 3 -1349 435 160 3 -241 81 311 3 -295 205 296 3 -50 57 113 3 -401 379 1911 3 -166 20 1066 3 -91 90 364 3 -275 241 311 3 -265 230 199 3 -269 283 236 3 -254 54 100 3 -236 283 208 3 -1890 401 1911 3 -1808 201 289 3 -28 1022 261 3 -43 158 192 3 -1335 468 8 3 -348 167 578 3 -275 302 223 3 -290 1083 135 3 -430 1758 838 3 -27 332 169 3 -91 248 90 3 -71 1696 1437 3 -126 285 1246 3 -988 319 449 3 -431 614 1479 3 -63 267 306 3 -1415 388 1651 3 -661 1083 290 3 -135 116 327 3 -267 299 233 3 -1036 619 118 3 -826 336 1641 3 -216 922 1459 3 -287 140 649 3 -99 98 66 3 -279 1012 212 3 -271 308 239 3 -262 11 634 3 -450 419 808 3 -68 1258 1456 3 -259 228 773 3 -680 145 95 3 -563 450 808 3 -291 202 292 3 -331 122 699 3 -1012 822 284 3 -163 172 73 3 -180 80 207 3 -234 202 291 3 -169 332 168 3 -207 80 302 3 -1044 1351 59 3 -407 616 364 3 -1676 337 120 3 -193 191 192 3 -63 229 267 3 -252 729 72 3 -1903 435 216 3 -98 133 66 3 -286 199 287 3 -153 699 743 3 -1437 906 1236 3 -215 307 1755 3 -351 159 252 3 -37 1277 563 3 -1159 570 778 3 -223 1229 1074 3 -627 38 88 3 -885 1066 208 3 -1386 68 353 3 -634 527 96 3 -26 109 155 3 -13 228 300 3 -1402 136 1931 3 -71 1875 59 3 -370 369 446 3 -106 41 286 3 -189 218 7 3 -136 104 1931 3 -826 1641 186 3 -207 302 224 3 -402 1077 138 3 -247 145 434 3 -1518 73 838 3 -441 698 453 3 -146 26 1120 3 -311 81 274 3 -391 1246 426 3 -174 1056 79 3 -402 438 1077 3 -235 254 202 3 -797 270 961 3 -1302 269 236 3 -166 190 417 3 -376 972 1111 3 -790 46 1084 3 -519 1480 246 3 -593 186 708 3 -1738 1388 1053 3 -60 843 330 3 -229 299 267 3 -503 661 132 3 -465 392 391 3 -109 218 155 3 -593 708 20 3 -164 183 48 3 -226 6 301 3 -960 47 251 3 -349 176 182 3 -831 356 175 3 -20 220 303 3 -1084 156 172 3 -376 103 1849 3 -38 140 88 3 -5 1890 1762 3 -159 1221 1767 3 -103 142 609 3 -1246 285 1077 3 -270 269 237 3 -177 1329 145 3 -124 1812 834 3 -1633 262 1343 3 -411 105 154 3 -134 108 29 3 -1111 972 1901 3 -169 47 187 3 -869 143 208 3 -1147 962 444 3 -389 444 340 3 -137 258 112 3 -146 25 187 3 -411 154 1496 3 -1005 1673 194 3 -506 1706 1351 3 -320 590 322 3 -1006 161 183 3 -627 88 89 3 -241 990 1075 3 -115 502 114 3 -38 128 649 3 -243 242 309 3 -234 268 202 3 -330 1485 150 3 -253 55 88 3 -10 220 250 3 -278 288 128 3 -1022 87 144 3 -55 230 266 3 -1012 284 1 3 -69 99 66 3 -301 6 227 3 -324 122 331 3 -450 437 419 3 -1601 153 184 3 -220 361 250 3 -271 239 1372 3 -212 1012 1 3 -307 1079 21 3 -328 135 327 3 -1083 72 729 3 -52 1084 172 3 -288 134 32 3 -339 1683 455 3 -1182 967 1466 3 -468 1111 1102 3 -401 1402 400 3 -97 371 96 3 -1402 1931 400 3 -390 1697 1099 3 -121 1406 315 3 -287 199 253 3 -1634 272 1075 3 -1632 460 386 3 -210 528 1372 3 -1116 258 205 3 -1591 503 132 3 -75 310 244 3 -718 1253 830 3 -51 1388 1738 3 -326 388 1415 3 -518 77 796 3 -1127 242 276 3 -873 264 206 3 -258 67 112 3 -1074 362 223 3 -580 194 1479 3 -243 273 242 3 -1479 194 1673 3 -1468 5 1729 3 -295 244 205 3 -153 718 184 3 -196 1160 1005 3 -32 287 649 3 -502 1203 131 3 -77 293 502 3 -327 384 906 3 -147 1580 1574 3 -1102 1901 4 3 -468 1102 8 3 -115 614 77 3 -261 214 298 3 -821 92 425 3 -351 1221 159 3 -217 1459 277 3 -744 191 193 3 -117 116 729 3 -32 134 29 3 -75 244 295 3 -117 729 252 3 -387 447 315 3 -1396 498 102 3 -64 1388 1098 3 -821 425 403 3 -301 1343 822 3 -324 331 451 3 -1237 156 222 3 -63 305 265 3 -284 198 1228 3 -1062 403 425 3 -143 885 208 3 -722 124 834 3 -1094 417 191 3 -1539 1496 1641 3 -967 380 1466 3 -580 1479 1574 3 -191 43 192 3 -463 460 1632 3 -838 1195 206 3 -831 315 356 3 -226 259 6 3 -699 422 331 3 -60 151 171 3 -465 884 1309 3 -836 360 463 3 -293 203 1203 3 -359 355 1724 3 -174 1250 442 3 -272 241 1075 3 -1 284 498 3 -884 426 438 3 -324 859 323 3 -57 110 127 3 -217 261 298 3 -718 152 7 3 -1487 1108 1911 3 -616 759 148 3 -962 446 444 3 -1509 312 61 3 -1533 362 1510 3 -421 405 1822 3 -229 265 199 3 -43 417 190 3 -241 275 990 3 -45 455 1044 3 -348 578 1094 3 -332 834 168 3 -398 347 637 3 -358 1036 60 3 -1195 873 206 3 -1725 359 682 3 -708 220 20 3 -109 13 218 3 -13 300 218 3 -89 55 222 3 -301 227 1343 3 -266 305 225 3 -113 67 221 3 -385 117 159 3 -1284 203 257 3 -1518 838 173 3 -60 330 151 3 -649 288 32 3 -251 233 1647 3 -798 1653 970 3 -12 1468 1729 3 -358 163 162 3 -450 459 437 3 -1808 1783 201 3 -163 1518 162 3 -30 1275 918 3 -87 46 144 3 -1808 306 1783 3 -1329 968 434 3 -1566 137 57 3 -239 308 238 3 -90 397 364 3 -140 253 88 3 -151 330 1873 3 -94 1830 1480 3 -77 614 796 3 -40 111 869 3 -362 1533 223 3 -73 1237 304 3 -1075 203 1634 3 -390 1099 389 3 -1044 469 1351 3 -1890 1911 1762 3 -45 1147 1099 3 -50 111 57 3 -185 1335 8 3 -111 110 57 3 -1485 355 1725 3 -990 85 257 3 -213 1558 960 3 -649 128 288 3 -103 102 1849 3 -31 268 234 3 -102 498 126 3 -249 75 98 3 -264 231 289 3 -578 166 1094 3 -1341 1420 165 3 -1558 146 187 3 -201 256 1083 3 -274 273 243 3 -1341 165 177 3 -290 135 328 3 -1406 387 315 3 -1566 296 137 3 -593 20 166 3 -309 994 221 3 -1566 62 296 3 -131 675 398 3 -1180 329 325 3 -4 1162 594 3 -124 122 346 3 -308 31 270 3 -1731 157 794 3 -1127 796 209 3 -961 280 204 3 -1127 276 518 3 -797 961 204 3 -1204 1123 84 3 -580 891 196 3 -960 1647 213 3 -1098 51 1632 3 -71 1706 1696 3 -994 312 1509 3 -37 178 1277 3 -1739 996 72 3 -46 87 627 3 -528 210 161 3 -797 204 246 3 -90 1591 397 3 -15 747 742 3 -97 96 527 3 -826 348 123 3 -1329 434 145 3 -149 70 180 3 -312 209 61 3 -131 1203 675 3 -105 104 250 3 -57 127 1566 3 -31 235 268 3 -1574 1479 147 3 -387 1891 844 3 -249 207 310 3 -422 699 1601 3 -609 142 352 3 -212 1253 263 3 -1663 451 1335 3 -1591 132 397 3 -279 219 259 3 -46 89 156 3 -326 742 388 3 -1180 125 339 3 -353 1259 164 3 -360 1693 359 3 -182 80 180 3 -291 292 127 3 -442 1499 447 3 -498 284 1228 3 -1676 1406 337 3 -297 1372 239 3 -237 269 1302 3 -27 722 332 3 -1437 76 906 3 -240 293 276 3 -400 1141 379 3 -138 634 96 3 -90 503 1591 3 -89 222 156 3 -207 224 310 3 -149 207 249 3 -1005 193 61 3 -150 179 1873 3 -1830 21 1480 3 -268 235 202 3 -243 309 67 3 -60 1798 358 3 -409 1624 152 3 -1717 467 82 3 -274 243 1116 3 -875 401 429 3 -322 1406 1676 3 -71 1437 1236 3 -130 29 106 3 -1165 262 634 3 -336 1539 1641 3 -994 242 312 3 -435 780 922 3 -32 29 130 3 -839 176 175 3 -1719 1036 119 3 -248 78 503 3 -200 773 255 3 -1852 412 1062 3 -305 230 265 3 -196 433 1160 3 -182 176 839 3 -107 26 146 3 -1641 709 186 3 -27 169 188 3 -182 839 80 3 -399 114 131 3 -1229 223 302 3 -299 213 1647 3 -1287 1204 613 3 -135 729 116 3 -455 1683 469 3 -287 253 140 3 -1402 401 875 3 -1456 349 182 3 -464 393 429 3 -292 202 254 3 -195 1044 59 3 -294 1284 139 3 -1144 225 873 3 -278 200 288 3 -87 86 627 3 -4 1866 1162 3 -1349 160 97 3 -295 296 133 3 -394 1653 368 3 -419 437 1133 3 -1601 699 153 3 -843 1485 330 3 -237 281 280 3 -121 831 584 3 -419 680 367 3 -192 1509 61 3 -13 255 228 3 -26 155 1120 3 -1316 352 212 3 -188 25 189 3 -174 79 1250 3 -357 1731 356 3 -271 235 308 3 -183 161 210 3 -63 265 229 3 -282 251 211 3 -296 258 137 3 -103 609 1396 3 -101 528 161 3 -1351 1706 59 3 -619 386 118 3 -830 352 1100 3 -300 1018 218 3 -144 790 170 3 -321 320 1676 3 -35 1094 191 3 -320 322 1676 3 -445 342 561 3 -165 353 164 3 -1302 236 281 3 -844 74 174 3 -444 446 369 3 -1680 348 35 3 -1873 179 688 3 -826 186 167 3 -76 1717 82 3 -1310 85 990 3 -230 253 199 3 -260 519 775 3 -149 69 70 3 -465 374 392 3 -422 1601 421 3 -1343 262 198 3 -329 1180 339 3 -1369 196 891 3 -1284 1919 139 3 -54 235 271 3 -235 54 254 3 -190 143 883 3 -661 201 1083 3 -305 306 231 3 -305 63 306 3 -337 121 1258 3 -15 185 747 3 -388 441 336 3 -1388 64 590 3 -1036 118 843 3 -74 988 1056 3 -359 1693 682 3 -238 270 797 3 -773 228 255 3 -822 198 284 3 -1388 590 1053 3 -1496 154 709 3 -380 399 1466 3 -698 8 594 3 -390 323 1697 3 -132 290 396 3 -356 1731 794 3 -124 346 1812 3 -197 1186 1221 3 -276 293 518 3 -1558 107 146 3 -1388 51 1098 3 -392 102 126 3 -967 506 381 3 -1203 1284 294 3 -74 844 1891 3 -176 831 175 3 -1345 446 71 3 -263 7 1018 3 -1651 826 123 3 -743 722 27 3 -1014 1108 1487 3 -283 40 869 3 -1079 797 246 3 -519 246 204 3 -309 242 994 3 -1159 836 1538 3 -431 1673 209 3 -115 147 614 3 -1182 1717 76 3 -1539 410 1496 3 -240 1634 293 3 -126 1246 391 3 -145 1133 1341 3 -449 343 445 3 -960 251 1647 3 -125 1119 1369 3 -1873 330 150 3 -190 1066 885 3 -69 1006 70 3 -24 12 1159 3 -35 191 744 3 -599 1674 82 3 -188 187 25 3 -188 169 187 3 -719 29 108 3 -719 107 106 3 -285 1165 138 3 -719 108 109 3 -317 619 1719 3 -1096 1903 179 3 -719 106 29 3 -26 719 109 3 -869 208 283 3 -97 160 1726 3 -1275 742 326 3 -1456 1258 349 3 -304 1195 73 3 -41 213 299 3 -308 270 238 3 -298 214 34 3 -130 287 32 3 -1543 164 48 3 -1468 464 5 3 -286 287 130 3 -167 186 593 3 -1538 836 37 3 -464 1890 5 3 -463 360 1724 3 -69 101 161 3 -136 1908 104 3 -185 8 698 3 -462 410 1539 3 -259 314 6 3 -83 1295 613 3 -972 374 1264 3 -442 1715 357 3 -290 328 396 3 -1697 859 1944 3 -264 289 78 3 -1485 1725 150 3 -269 234 283 3 -83 613 1062 3 -836 778 360 3 -256 1739 72 3 -1287 1295 561 3 -918 45 30 3 -368 95 94 3 -742 747 388 3 -256 72 1083 3 -1739 282 996 3 -81 240 273 3 -699 122 743 3 -1479 1673 431 3 -1133 437 1341 3 -200 245 314 3 -450 563 459 3 -339 1369 891 3 -1310 223 1533 3 -1310 275 223 3 -45 195 1147 3 -266 230 305 3 -1014 1162 1108 3 -70 1006 183 3 -397 132 396 3 -221 994 1509 3 -407 561 342 3 -277 227 313 3 -80 839 1229 3 -212 352 830 3 -747 698 441 3 -830 1253 212 3 -127 62 1566 3 -405 1111 1822 3 -570 371 372 3 -129 519 1856 3 -649 140 38 3 -243 258 1116 3 -884 1331 1309 3 -481 162 173 3 -141 133 62 3 -884 438 1331 3 -285 138 1077 3 -299 1647 233 3 -869 111 143 3 -324 1663 859 3 -412 1731 357 3 -215 968 1353 3 -1499 357 356 3 -115 77 502 3 -54 271 528 3 -1624 188 152 3 -1077 438 426 3 -1852 157 1731 3 -132 661 290 3 -1111 468 1822 3 -1812 346 390 3 -798 970 12 3 -1036 843 60 3 -709 708 186 3 -259 219 228 3 -1159 778 836 3 -1147 195 962 3 -329 339 455 3 -120 337 1386 3 -165 1543 177 3 -104 10 250 3 -1762 1911 2 3 -127 292 62 3 -451 1822 468 3 -141 254 100 3 -1165 198 262 3 -282 233 251 3 -288 200 255 3 -465 391 884 3 -386 460 355 3 -235 31 308 3 -1944 15 742 3 -759 616 407 3 -1674 1356 845 3 -31 234 269 3 -234 291 40 3 -181 180 70 3 -164 181 183 3 -82 1952 76 3 -372 371 97 3 -264 78 206 3 -1275 1944 742 3 -1856 519 260 3 -430 206 248 3 -1133 145 680 3 -24 798 12 3 -498 1228 126 3 -92 1510 93 3 -66 133 141 3 -1632 51 178 3 -86 128 38 3 -66 141 100 3 -387 844 447 3 -195 59 962 3 -1310 1533 85 3 -808 367 798 3 -1162 1866 1108 3 -469 1683 344 3 -1056 988 449 3 -1119 1680 35 3 -722 834 332 3 -1264 1895 2 3 -1696 967 1182 3 -248 503 90 3 -1253 7 263 3 -1264 465 1895 3 -988 318 317 3 -300 219 1018 3 -1345 385 370 3 -120 1386 353 3 -225 305 231 3 -217 277 313 3 -48 210 297 3 -293 1634 203 3 -836 463 37 3 -634 11 527 3 -174 442 844 3 -343 735 759 3 -181 182 180 3 -361 154 250 3 -399 131 398 3 -86 278 128 3 -1558 187 960 3 -431 796 614 3 -118 355 1485 3 -118 386 355 3 -463 1724 460 3 -1225 347 403 3 -1909 12 1729 3 -43 190 883 3 -103 376 404 3 -142 404 1799 3 -675 294 1554 3 -69 161 1006 3 -1729 1331 438 3 -94 95 247 3 -162 1518 173 3 -1895 465 1309 3 -1724 355 460 3 -720 409 152 3 -1812 389 340 3 -1799 421 1318 3 -98 75 295 3 -1386 337 1258 3 -1098 1632 386 3 -698 594 462 3 -1719 619 1036 3 -138 1165 634 3 -278 245 200 3 -437 459 432 3 -1275 326 325 3 -385 159 1767 3 -400 1931 1141 3 -27 188 1624 3 -376 374 972 3 -451 468 1335 3 -388 336 1651 3 -1693 1096 682 3 -248 206 78 3 -570 12 1909 3 -967 381 380 3 -682 1096 179 3 -41 299 229 3 -467 637 82 3 -1371 875 393 3 -110 40 291 3 -138 96 402 3 -349 584 176 3 -518 293 77 3 -402 96 371 3 -1096 160 435 3 -970 464 1468 3 -838 73 1195 3 -590 1891 322 3 -467 398 637 3 -231 1808 289 3 -28 87 1022 3 -968 215 434 3 -434 215 1755 3 -362 157 93 3 -794 157 362 3 -245 313 314 3 -261 1022 214 3 -260 136 1402 3 -67 309 221 3 -288 255 134 3 -503 289 661 3 -64 988 74 3 -240 272 1634 3 -1729 5 1331 3 -433 744 1160 3 -74 1891 64 3 -37 463 178 3 -183 210 48 3 -151 1873 34 3 -346 324 323 3 -336 826 1651 3 -327 116 384 3 -720 152 718 3 -1079 246 21 3 -412 1852 1731 3 -325 1415 1410 3 -312 242 1127 3 -1250 79 1295 3 -790 1084 52 3 -154 361 709 3 -359 1725 355 3 -407 1287 561 3 -1798 171 163 3 -192 158 221 3 -181 70 183 3 -873 225 264 3 -171 52 172 3 -348 1094 35 3 -1100 1318 184 3 -403 1062 1106 3 -322 387 1406 3 -119 481 333 3 -94 247 1830 3 -340 1186 834 3 -1875 446 962 3 -445 561 79 3 -381 1048 380 3 -906 76 845 3 -179 1903 688 3 -214 144 170 3 -214 1022 144 3 -442 357 1499 3 -1277 178 1738 3 -1901 972 1264 3 -1147 389 1099 3 -425 92 93 3 -407 364 1204 3 -381 506 344 3 -368 1653 798 3 -142 1318 1100 3 -451 331 422 3 -794 362 1074 3 -297 210 1372 3 -1349 780 435 3 -609 1316 1396 3 -237 1302 281 3 -255 13 108 3 -134 255 108 3 -109 108 13 3 -1102 594 8 3 -339 891 1683 3 -1674 845 1952 3 -1903 1096 435 3 -60 171 1798 3 -1250 1295 83 3 -193 192 61 3 -1487 1911 379 3 -1706 71 59 3 -718 7 1253 3 -249 310 75 3 -780 11 922 3 -280 775 204 3 -1663 15 859 3 -152 189 7 3 -343 342 445 3 -1014 1487 411 3 -1696 506 967 3 -103 1396 102 3 -442 1250 1715 3 -86 28 278 3 -111 40 110 3 -1510 362 93 3 -188 189 152 3 -599 637 1225 3 -429 401 1890 3 -1908 10 104 3 -115 114 380 3 -735 1758 148 3 -122 324 346 3 -325 326 1415 3 -1758 173 838 3 -217 313 245 3 -580 196 194 3 -196 1005 194 3 -95 145 247 3 -226 1012 279 3 -62 133 296 3 -1873 688 34 3 -425 93 1852 3 -1144 873 304 3 -1259 181 164 3 -340 369 1186 3 -225 231 264 3 -1014 411 410 3 -883 50 158 3 -1858 91 148 3 -224 244 310 3 -960 187 47 3 -435 922 216 3 -324 451 1663 3 -1762 1309 5 3 -211 197 351 3 -637 347 1225 3 -21 1830 1755 3 -364 397 1123 3 -231 306 1808 3 -292 141 62 3 -110 291 127 3 -393 464 1653 3 -227 277 1633 3 -404 376 1111 3 -1250 83 1715 3 -24 1538 808 3 -1633 11 262 3 -411 1496 410 3 -119 1526 481 3 -244 274 205 3 -1755 307 21 3 -1386 1258 68 3 -261 245 28 3 -1075 257 203 3 -1075 990 257 3 -453 462 1539 3 -304 222 1144 3 -28 245 278 3 -145 1341 177 3 -1127 518 796 3 -988 317 319 3 -232 233 282 3 -467 399 398 3 -351 197 1221 3 -759 735 148 3 -337 1406 121 3 -226 822 1012 3 -1341 437 1420 3 -91 616 148 3 -1295 1287 613 3 -219 279 263 3 -24 1159 1538 3 -237 280 961 3 -300 228 219 3 -143 50 883 3 -115 1048 147 3 -1919 1510 92 3 -481 735 343 3 -1083 729 135 3 -459 456 432 3 -1931 104 1141 3 -1356 396 328 3 -430 838 206 3 -1496 709 1641 3 -374 465 1264 3 -248 91 1858 3 -353 68 1259 3 -78 289 503 3 -270 237 961 3 -266 1144 222 3 -1952 845 76 3 -402 1909 438 3 -252 72 996 3 -111 50 143 3 -1715 1062 412 3 -344 1683 1574 3 -163 73 1518 3 -627 86 38 3 -195 45 1044 3 -312 1127 209 3 -51 1738 178 3 -409 27 1624 3 -1697 323 859 3 -1725 682 150 3 -453 698 462 3 -1048 115 380 3 -616 91 364 3 -28 86 87 3 -246 1480 21 3 -129 1480 519 3 -79 561 1295 3 -394 1371 393 3 -1697 30 1099 3 -506 1351 469 3 -1891 387 322 3 -304 873 1195 3 -137 112 57 3 -243 67 258 3 -759 407 342 3 -1258 584 349 3 -455 469 1044 3 -1159 12 570 3 -101 100 54 3 -1683 891 580 3 -845 328 327 3 -747 185 698 3 -394 393 1653 3 -1783 256 201 3 -1715 412 357 3 -211 351 996 3 -99 69 149 3 -148 1758 1858 3 -1487 105 411 3 -1099 30 45 3 -367 680 368 3 -48 297 1353 3 -313 227 6 3 -313 6 314 3 -613 1204 84 3 -390 346 323 3 -1738 1053 456 3 -292 254 141 3 -166 1066 190 3 -384 116 117 3 -385 384 117 3 -69 66 101 3 -1849 102 392 3 -467 1466 399 3 -397 396 466 3 -580 1574 1683 3 -55 266 222 3 -1526 162 481 3 -61 209 1673 3 -462 1014 410 3 -466 396 1356 3 -432 1420 437 3 -277 922 11 3 -1119 35 744 3 -31 269 270 3 -1162 1014 594 3 -80 1229 302 3 -1182 467 1717 3 -227 1633 1343 3 -722 122 124 3 -79 1056 445 3 -306 267 232 3 -232 267 233 3 -996 282 211 3 -129 1856 1371 3 -113 221 158 3 -146 1120 25 3 -64 1891 590 3 -340 444 369 3 -277 1459 922 3 -1182 1466 467 3 -1203 203 1284 3 -107 41 106 3 -527 11 780 3 -456 1053 321 3 -249 99 149 3 -996 351 252 3 -1601 1318 421 3 -747 441 388 3 -25 1120 189 3 -151 52 171 3 -1221 1186 1767 3 -1719 119 319 3 -149 180 207 3 -281 236 303 3 -163 171 172 3 -463 1632 178 3 -219 263 1018 3 -775 519 204 3 -1903 216 688 3 -192 221 1509 3 -333 343 449 3 -506 1696 1706 3 -1715 83 1062 3 -150 682 179 3 -432 321 622 3 -432 456 321 3 -1799 404 405 3 -1726 160 1693 3 -1858 1758 430 3 -613 1106 1062 3 -352 142 1100 3 -464 429 1890 3 -122 722 743 3 -1724 360 359 3 -404 1111 405 3 -1866 2 1911 3 -234 40 283 3 -1693 160 1096 3 -1048 381 1580 3 -153 409 720 3 -153 743 409 3 -200 314 773 3 -743 27 409 3 -599 1225 1106 3 -844 442 447 3 -403 1106 1225 3 -251 47 211 3 -1204 364 1123 3 -339 125 1369 3 -376 1849 374 3 -368 94 394 3 -121 315 831 3 -502 293 1203 3 -1005 61 1673 3 -71 1236 1345 3 -1246 1077 426 3 -347 1443 403 3 -417 1094 166 3 -453 1539 336 3 -321 1053 320 3 -392 126 391 3 -438 1909 1729 3 -147 1048 1580 3 -622 120 353 3 -688 216 34 3 -139 821 1443 3 -144 46 790 3 -527 780 1349 3 -1437 1182 76 3 -84 1674 599 3 -168 197 47 3 -883 158 43 3 -319 333 449 3 -1353 297 215 3 -117 252 159 3 -1944 859 15 3 -1499 315 447 3 -119 333 319 3 -432 622 1420 3 -422 421 1822 3 -1005 1160 193 3 -422 1822 451 3 -661 289 201 3 -296 205 258 3 -4 1264 1866 3 -125 1180 1410 3 -297 239 307 3 -1526 358 162 3 -232 1739 1783 3 -1663 1335 185 3 -306 232 1783 3 -1264 2 1866 3 -1908 280 10 3 -385 1236 384 3 -449 445 1056 3 -1812 340 834 3 -232 282 1739 3 -384 1236 906 3 -1852 93 157 3 -353 1420 622 3 -275 1310 990 3 -143 190 885 3 -675 1203 294 3 -94 1480 129 3 -622 1676 120 3 -584 831 176 3 -285 1228 1165 3 -26 107 719 3 -1228 285 126 3 -401 400 379 3 -1696 1182 1437 3 -153 720 718 3 -1236 385 1345 3 -1554 1443 347 3 -175 794 1074 3 -402 371 1909 3 -1345 370 446 3 -361 220 708 3 -139 92 821 3 -220 281 303 3 -196 1369 433 3 -830 1100 184 3 -393 875 429 3 -1074 839 175 3 -294 1443 1554 3 -169 168 47 3 -1036 1526 119 3 -101 54 528 3 -1180 325 1410 3 -528 271 1372 3 -239 238 307 3 -224 311 244 3 -826 167 348 3 -1919 85 1510 3 -1767 369 370 3 -421 1799 405 3 -298 34 216 3 -397 466 1123 3 -229 199 286 3 -41 229 286 3 -259 773 314 3 -1369 1119 433 3 -172 156 1237 3 -12 970 1468 3 -10 281 220 3 -311 274 244 3 -1147 444 389 3 -174 74 1056 3 -213 107 1558 3 -321 1676 622 3 -260 1402 875 3 -1479 614 147 3 -1287 407 1204 3 -1141 104 105 3 -1858 430 248 3 -230 55 253 3 -191 417 43 3 -68 1456 181 3 -64 1098 318 3 -884 391 426 3 -64 318 988 3 -1053 590 320 3 -570 1909 371 3 -82 637 599 3 -1415 1651 123 3 -139 1919 92 3 -129 1371 394 3 -1079 238 797 3 -845 1356 328 3 -41 107 213 3 -1277 1738 459 3 -1738 456 459 3 -1186 369 1767 3 -136 775 1908 3 -274 1116 205 3 -1674 1952 82 3 -1120 155 189 3 -73 172 1237 3 -481 173 735 3 -275 224 302 3 -10 280 281 3 -808 1538 563 3 -593 166 578 3 -1018 7 218 3 -165 164 1543 3 -455 918 329 3 -356 794 175 3 -1353 968 1543 3 -466 1356 1674 3 -15 1663 185 3 -790 52 170 3 -1653 464 970 3 -1580 381 344 3 -294 139 1443 3 -94 129 394 3 -318 1098 386 3 -462 594 1014 3 -778 372 360 3 -778 570 372 3 -1228 198 1165 3 -372 97 1726 3 -260 775 136 3 -189 155 218 3 -1 1316 212 3 -315 1499 356 3 -226 279 259 3 -808 798 24 3 -216 1459 298 3 -1229 839 1074 3 -1755 247 434 3 -217 245 261 3 -105 250 154 3 -1329 177 1543 3 -834 1186 168 3 -1353 1543 48 3 -968 1329 1543 3 -1697 1944 30 3 -1875 71 446 3 -37 563 1538 3 -217 298 1459 3 -142 1799 1318 3 -275 311 224 3 -1601 184 1318 3 -380 114 399 3 -1856 875 1371 3 -1443 821 403 3 -599 1106 84 3 -1726 1693 360 3 -167 593 578 3 -304 1237 222 3 -1284 257 1919 3 -1762 1895 1309 3 -97 527 1349 3 -226 301 822 3 -101 66 100 3 -215 297 307 3 -81 273 274 3 -30 1944 1275 3 -1396 1 498 3 -735 173 1758 3 -20 303 1066 3 -1066 303 208 3 -303 236 208 3 -277 11 1633 3 -718 830 184 3 -1316 609 352 3 -214 170 34 3 -1316 1 1396 3 -1123 466 84 3 -347 398 1554 3 -1908 775 280 3 -1849 392 374 3 -563 1277 459 3 -327 906 845 3 -343 759 342 3 -266 225 1144 3 -1133 680 419 3 -368 798 367 3 -99 249 98 3 -822 1343 198 3 -1856 260 875 3 -1415 123 1410 3 -273 276 242 3 -193 1160 744 3 -918 1275 325 3 -1852 1062 425 3 -113 112 67 3 -113 57 112 3 -50 113 158 3 -1783 1739 256 3 -307 238 1079 3 -1526 1036 358 3 -85 1533 1510 3 -675 1554 398 3 -843 118 1485 3 -1102 4 594 3 -385 1767 370 3 -1574 1580 344 3 -613 84 1106 3 -709 361 708 3 -372 1726 360 3 -1487 379 1141 3 -1487 1141 105 3 -209 796 431 3 -333 481 343 3 -279 212 263 3 -1456 182 181 3 -1259 68 181 3 -441 453 336 3 -318 386 619 3 -317 318 619 3 -1309 1331 5 3 -103 404 142 3 -325 329 918 3 -390 389 1812 3 -1798 163 358 3 -81 272 240 3 -151 34 170 3 -419 367 808 3 -1410 123 1680 3 -240 276 273 3 -1410 1680 1119 3 -125 1410 1119 3 -1258 121 584 3 -151 170 52 3 -1830 247 1755 3 -680 95 368 3 -123 348 1680 3 -1108 1866 1911 3 -344 506 469 3 -1119 744 433 3 -1102 1111 1901 3 -1420 353 165 3 -47 197 211 3 -98 295 133 3 -257 85 1919 3 -46 627 89 3 -168 1186 197 3 -962 59 1875 3 -1901 1264 4 3 +696 +87 28 86 1 +240 77 272 1 +68 181 164 1 +113 112 67 1 +64 119 74 1 +51 523 120 1 +27 623 124 1 +213 295 293 1 +102 278 126 1 +94 254 129 1 +226 278 1 1 +28 87 825 1 +648 217 255 1 +101 54 210 1 +167 185 186 1 +304 242 307 1 +102 1 278 1 +237 264 236 1 +110 40 285 1 +11 227 273 1 +43 158 192 1 +278 198 279 1 +31 234 264 1 +284 135 82 1 +107 26 146 1 +196 125 193 1 +289 252 136 1 +25 525 189 1 +290 205 291 1 +46 89 156 1 +271 40 492 1 +172 222 73 1 +155 588 218 1 +261 299 225 1 +274 282 128 1 +134 249 108 1 +225 257 206 1 +270 241 305 1 +81 267 240 1 +77 474 272 1 +81 240 268 1 +362 742 160 1 +45 196 195 1 +169 168 47 1 +498 107 146 1 +60 118 151 1 +46 87 496 1 +41 498 293 1 +124 45 168 1 +97 12 96 1 +21 95 973 1 +28 245 274 1 +106 280 130 1 +309 6 259 1 +125 35 193 1 +1047 131 82 1 +63 260 229 1 +194 731 657 1 +2 126 136 1 +2 102 126 1 +12 129 5 1 +94 129 12 1 +29 130 32 1 +66 133 62 1 +13 249 473 1 +230 63 299 1 +251 85 92 1 +60 151 171 1 +77 115 474 1 +296 7 661 1 +191 166 190 1 +248 72 116 1 +496 87 86 1 +214 821 294 1 +113 67 562 1 +71 115 76 1 +263 235 202 1 +825 87 144 1 +266 303 239 1 +85 241 270 1 +28 825 255 1 +191 43 192 1 +153 152 7 1 +122 27 152 1 +188 169 187 1 +83 556 148 1 +294 742 216 1 +89 222 156 1 +139 92 84 1 +588 310 218 1 +375 93 85 1 +362 11 273 1 +167 186 20 1 +212 142 184 1 +238 204 254 1 +31 263 234 1 +281 199 292 1 +267 241 203 1 +86 28 274 1 +195 197 168 1 +95 24 145 1 +195 59 197 1 +31 235 263 1 +221 741 61 1 +27 122 623 1 +168 197 47 1 +196 61 194 1 +1 632 256 1 +182 121 176 1 +257 78 686 1 +197 640 458 1 +556 494 148 1 +256 212 296 1 +219 256 296 1 +87 46 144 1 +210 266 685 1 +153 122 152 1 +212 632 142 1 +189 661 7 1 +46 496 89 1 +283 284 132 1 +422 254 21 1 +206 686 494 1 +675 154 220 1 +247 11 96 1 +79 494 556 1 +939 275 48 1 +279 247 138 1 +241 85 251 1 +15 153 185 1 +234 202 285 1 +240 287 77 1 +272 474 209 1 +145 24 699 1 +496 38 88 1 +523 118 524 1 +280 41 229 1 +375 85 270 1 +454 722 220 1 +299 300 231 1 +69 570 101 1 +176 175 80 1 +270 305 224 1 +63 230 260 1 +280 199 281 1 +300 232 201 1 +280 281 130 1 +675 306 20 1 +135 116 76 1 +255 245 28 1 +243 253 205 1 +59 640 197 1 +227 6 308 1 +250 54 100 1 +494 686 148 1 +186 675 20 1 +45 125 196 1 +208 492 143 1 +307 209 741 1 +305 81 269 1 +179 742 34 1 +292 55 88 1 +473 228 219 1 +141 100 66 1 +291 253 137 1 +240 203 287 1 +211 246 276 1 +79 556 175 1 +227 247 198 1 +257 686 206 1 +235 250 202 1 +498 146 213 1 +103 1 102 1 +796 699 177 1 +509 99 149 1 +70 526 183 1 +64 524 119 1 +115 114 76 1 +283 201 284 1 +115 77 114 1 +69 99 570 1 +35 191 193 1 +169 47 187 1 +221 307 741 1 +113 562 158 1 +685 239 651 1 +506 106 29 1 +111 50 143 1 +705 492 208 1 +15 185 167 1 +230 261 55 1 +26 107 506 1 +64 523 524 1 +299 63 300 1 +498 213 293 1 +257 231 78 1 +178 177 37 1 +277 509 207 1 +243 684 253 1 +281 140 32 1 +50 111 519 1 +206 494 737 1 +265 264 237 1 +230 292 199 1 +291 205 253 1 +13 310 588 1 +165 164 48 1 +164 183 48 1 +89 55 222 1 +931 154 8 1 +63 229 262 1 +454 301 722 1 +75 509 277 1 +214 144 170 1 +244 269 205 1 +118 51 150 1 +193 191 192 1 +265 237 204 1 +939 161 210 1 +176 174 175 1 +163 172 73 1 +237 236 301 1 +261 222 55 1 +51 120 165 1 +165 120 164 1 +238 265 204 1 +27 124 169 1 +80 297 207 1 +121 74 176 1 +188 187 25 1 +277 297 224 1 +496 88 89 1 +15 122 153 1 +282 134 32 1 +32 140 38 1 +69 161 526 1 +119 163 162 1 +217 308 245 1 +79 173 494 1 +83 93 157 1 +5 138 12 1 +147 731 474 1 +50 113 158 1 +307 272 209 1 +287 203 288 1 +623 334 124 1 +307 242 272 1 +126 278 279 1 +458 1127 47 1 +525 155 661 1 +562 221 158 1 +258 227 198 1 +141 250 100 1 +454 220 154 1 +494 173 737 1 +213 1127 295 1 +243 304 684 1 +261 230 299 1 +181 180 70 1 +181 182 180 1 +296 661 218 1 +212 7 296 1 +508 12 97 1 +152 188 189 1 +30 528 123 1 +188 27 169 1 +91 90 84 1 +623 122 30 1 +95 21 94 1 +215 302 973 1 +143 50 43 1 +260 230 199 1 +83 84 93 1 +282 200 249 1 +252 10 104 1 +255 214 294 1 +4 2 105 1 +290 291 133 1 +175 157 223 1 +51 178 150 1 +190 20 208 1 +215 973 796 1 +99 69 149 1 +686 91 148 1 +651 239 302 1 +524 60 119 1 +136 252 104 1 +215 651 302 1 +295 233 293 1 +173 73 737 1 +130 281 32 1 +279 138 5 1 +239 238 302 1 +188 25 189 1 +289 254 204 1 +164 181 183 1 +249 13 108 1 +186 154 675 1 +174 173 79 1 +294 34 742 1 +93 84 92 1 +285 286 127 1 +142 8 184 1 +288 139 723 1 +298 225 206 1 +274 200 282 1 +166 123 167 1 +70 180 149 1 +175 223 80 1 +224 244 277 1 +197 458 47 1 +238 254 422 1 +196 193 61 1 +60 163 119 1 +657 707 59 1 +191 190 43 1 +281 292 140 1 +181 70 183 1 +83 157 556 1 +167 20 166 1 +235 31 303 1 +91 83 148 1 +105 2 104 1 +235 54 250 1 +91 78 90 1 +303 265 238 1 +215 275 651 1 +192 221 61 1 +89 88 55 1 +310 296 218 1 +973 302 21 1 +83 91 84 1 +232 233 276 1 +640 159 458 1 +99 75 98 1 +94 21 254 1 +199 280 229 1 +241 251 203 1 +240 267 203 1 +117 246 159 1 +722 306 220 1 +67 304 562 1 +297 223 270 1 +8 154 186 1 +50 158 43 1 +506 107 106 1 +32 134 29 1 +291 1074 62 1 +474 731 209 1 +523 51 118 1 +119 162 74 1 +24 97 160 1 +41 107 498 1 +506 29 108 1 +95 94 508 1 +214 170 821 1 +274 245 200 1 +289 204 252 1 +182 80 180 1 +57 110 127 1 +74 162 174 1 +172 156 222 1 +309 259 228 1 +111 40 110 1 +40 111 492 1 +161 939 183 1 +124 334 45 1 +623 30 334 1 +302 238 422 1 +243 242 304 1 +699 724 37 1 +109 108 13 1 +169 124 168 1 +287 288 131 1 +128 282 32 1 +239 303 238 1 +523 330 120 1 +523 64 330 1 +524 118 60 1 +136 104 2 1 +225 299 231 1 +200 245 309 1 +528 15 123 1 +529 123 35 1 +126 279 5 1 +51 165 178 1 +710 261 225 1 +76 131 1047 1 +76 114 131 1 +266 235 303 1 +684 304 67 1 +101 210 161 1 +229 293 262 1 +1 103 632 1 +310 219 296 1 +31 264 265 1 +82 288 723 1 +171 151 170 1 +81 241 267 1 +24 95 508 1 +684 67 253 1 +289 136 5 1 +27 188 152 1 +135 284 248 1 +286 250 141 1 +298 206 737 1 +234 263 202 1 +362 216 742 1 +245 308 309 1 +195 196 194 1 +223 375 270 1 +78 91 686 1 +45 195 168 1 +228 259 219 1 +298 737 73 1 +120 330 68 1 +297 270 224 1 +135 248 116 1 +253 67 112 1 +273 227 308 1 +556 157 175 1 +29 106 130 1 +648 294 216 1 +685 266 239 1 +632 103 142 1 +146 26 525 1 +75 99 509 1 +52 170 144 1 +217 648 273 1 +151 118 150 1 +63 262 300 1 +231 361 78 1 +231 300 361 1 +35 125 529 1 +146 525 25 1 +243 268 242 1 +211 295 1127 1 +237 10 252 1 +125 45 334 1 +26 506 109 1 +46 156 52 1 +193 192 61 1 +76 116 117 1 +117 116 246 1 +821 34 294 1 +232 262 233 1 +288 203 251 1 +207 297 277 1 +180 80 207 1 +224 305 244 1 +6 226 259 1 +152 189 7 1 +213 47 1127 1 +237 252 204 1 +232 248 201 1 +305 269 244 1 +361 300 201 1 +300 262 232 1 +256 632 212 1 +90 132 84 1 +200 309 228 1 +226 256 259 1 +234 271 264 1 +4 103 2 1 +362 273 216 1 +306 208 20 1 +259 256 219 1 +96 11 97 1 +825 214 255 1 +129 254 289 1 +142 4 931 1 +298 710 225 1 +74 174 176 1 +241 81 305 1 +93 92 85 1 +6 258 226 1 +330 121 68 1 +217 245 255 1 +68 182 181 1 +226 198 278 1 +525 661 189 1 +98 290 133 1 +570 99 98 1 +1074 127 286 1 +275 796 48 1 +183 939 48 1 +275 685 651 1 +661 155 218 1 +174 79 175 1 +529 334 30 1 +129 289 5 1 +131 288 82 1 +210 54 266 1 +57 519 110 1 +90 283 132 1 +132 284 82 1 +195 194 59 1 +64 121 330 1 +59 194 657 1 +133 291 62 1 +57 127 1074 1 +121 64 74 1 +149 526 70 1 +166 20 190 1 +174 162 173 1 +151 34 170 1 +178 165 177 1 +84 723 139 1 +731 741 209 1 +722 236 705 1 +796 973 145 1 +284 201 248 1 +149 180 207 1 +81 268 269 1 +973 95 145 1 +86 274 128 1 +75 277 244 1 +276 233 295 1 +207 509 149 1 +10 301 454 1 +710 222 261 1 +244 290 75 1 +179 724 742 1 +140 88 38 1 +38 128 32 1 +43 190 143 1 +310 473 219 1 +529 125 334 1 +136 126 5 1 +98 75 290 1 +162 73 173 1 +139 251 92 1 +705 236 271 1 +80 223 297 1 +724 160 742 1 +86 128 38 1 +60 171 163 1 +143 190 208 1 +496 86 38 1 +288 251 139 1 +303 31 265 1 +222 710 298 1 +137 112 57 1 +570 98 66 1 +15 167 123 1 +107 41 106 1 +291 137 1074 1 +50 519 113 1 +648 255 294 1 +1074 286 62 1 +122 528 30 1 +120 68 164 1 +269 268 243 1 +526 161 183 1 +722 705 306 1 +68 121 182 1 +146 25 187 1 +149 69 526 1 +103 4 142 1 +106 41 280 1 +723 132 82 1 +825 144 214 1 +362 97 11 1 +13 473 310 1 +54 235 266 1 +71 117 159 1 +35 166 191 1 +6 227 258 1 +285 202 286 1 +185 8 186 1 +707 159 640 1 +234 40 271 1 +103 102 2 1 +648 216 273 1 +192 158 221 1 +519 112 113 1 +4 105 154 1 +142 931 8 1 +82 135 1047 1 +90 78 283 1 +234 285 40 1 +506 108 109 1 +699 24 724 1 +276 295 211 1 +458 211 1127 1 +105 454 154 1 +4 154 931 1 +101 100 54 1 +286 141 62 1 +26 109 155 1 +282 249 134 1 +111 110 519 1 +147 71 707 1 +657 147 707 1 +246 116 72 1 +268 272 242 1 +240 272 268 1 +66 62 141 1 +138 247 96 1 +306 705 208 1 +194 61 731 1 +97 362 160 1 +492 111 143 1 +165 48 177 1 +796 177 48 1 +707 640 59 1 +230 55 292 1 +138 96 12 1 +225 231 257 1 +302 422 21 1 +150 179 34 1 +151 150 34 1 +246 72 276 1 +105 104 10 1 +570 100 101 1 +562 304 221 1 +237 301 10 1 +134 108 29 1 +110 285 127 1 +731 61 741 1 +41 293 229 1 +213 187 47 1 +144 46 52 1 +474 115 147 1 +115 71 147 1 +109 13 588 1 +171 52 172 1 +69 101 161 1 +137 253 112 1 +307 221 304 1 +212 184 7 1 +279 198 247 1 +159 246 211 1 +226 1 256 1 +222 298 73 1 +217 273 308 1 +473 249 228 1 +71 76 117 1 +52 156 172 1 +114 287 131 1 +24 508 97 1 +301 236 722 1 +26 155 525 1 +109 588 155 1 +114 77 287 1 +185 184 8 1 +269 243 205 1 +122 15 528 1 +157 375 223 1 +182 176 80 1 +71 159 707 1 +260 199 229 1 +271 492 705 1 +73 162 163 1 +185 153 184 1 +699 37 177 1 +123 166 35 1 +37 724 179 1 +213 146 187 1 +458 159 211 1 +1047 135 76 1 +163 171 172 1 +309 308 6 1 +171 170 52 1 +1074 137 57 1 +939 210 275 1 +226 258 198 1 +232 72 248 1 +227 11 247 1 +570 66 100 1 +210 685 275 1 +250 286 202 1 +215 796 275 1 +153 7 184 1 +178 37 179 1 +150 178 179 1 +232 276 72 1 +93 375 157 1 +145 699 796 1 +105 10 454 1 +262 293 233 1 +264 271 236 1 +94 12 508 1 +24 160 724 1 +84 132 723 1 +57 112 519 1 +657 731 147 1 +821 170 34 1 +200 228 249 1 +361 283 78 1 +205 290 244 1 +220 306 675 1 +30 123 529 1 +140 292 88 1 +98 133 66 1 +361 201 283 1 End diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_internal_variables_interpolation_test_parameters.json b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_internal_variables_interpolation_test_parameters.json index e3d654e523c3..b0529cf69e68 100644 --- a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_internal_variables_interpolation_test_parameters.json +++ b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_internal_variables_interpolation_test_parameters.json @@ -12,7 +12,7 @@ "echo_level" : 0 }, "solver_settings" : { - "solver_type" : "solid_mechanics_implicit_dynamic_solver", + "solver_type" : "structural_mechanics_implicit_dynamic_solver", "echo_level" : 0, "solution_type" : "Dynamic", "time_integration_method" : "Implicit", @@ -22,6 +22,9 @@ "input_filename" : "mmg_lagrangian_test/beam2D_internal_variables_interpolation_test", "input_file_label" : 0 }, + "material_import_settings" :{ + "materials_filename": "mmg_lagrangian_test/materials_plastic_2D.json" + }, "line_search" : false, "convergence_criterion" : "Residual_criterion", "displacement_relative_tolerance" : 0.0001, @@ -37,10 +40,10 @@ "processes_sub_model_part_list" : ["Parts_Parts_Auto1","DISPLACEMENT_Displacement_Auto1","SelfWeight2D_Self_weight_Auto1"] }, "constraints_process_list" : [{ - "python_module" : "assign_vector_components_to_nodes_process", - "kratos_module" : "KratosMultiphysics.SolidMechanicsApplication", + "python_module" : "assign_vector_variable_process", + "kratos_module" : "KratosMultiphysics", "help" : "This process fixes the selected components of a given vector variable", - "process_name" : "AssignVectorComponentsToNodesProcess", + "process_name" : "AssignVectorProcess", "Parameters" : { "mesh_id" : 0, "model_part_name" : "DISPLACEMENT_Displacement_Auto1", @@ -50,17 +53,16 @@ } }], "loads_process_list" : [{ - "python_module" : "assign_modulus_and_direction_to_nodes_process", - "kratos_module" : "KratosMultiphysics.SolidMechanicsApplication", + "python_module" : "assign_vector_variable_process", + "kratos_module" : "KratosMultiphysics", "help" : "This process fixes all the components of a given vector variable", "check" : "DirectorVectorNonZero direction", - "process_name" : "AssignModulusAndDirectionToNodesProcess", + "process_name" : "AssignVectorProcess", "Parameters" : { "mesh_id" : 0, "model_part_name" : "SelfWeight2D_Self_weight_Auto1", "variable_name" : "VOLUME_ACCELERATION", - "modulus" : 9.81, - "direction" : [0.0,-1.0,0.0], + "value" : [0.0,-9.81,0.0], "interval" : [0.0,"End"] } }], diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_parameters.json b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_parameters.json index e7e25f63ee73..de0530a04ac4 100644 --- a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_parameters.json +++ b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_parameters.json @@ -4,7 +4,6 @@ "model_part_name" : "MainModelPart", "domain_size" : 2, "solve_problem" : true, - "solve_problem" : false, "problem_type" : "solid", "parallel_type" : "OpenMP", "time_step" : 0.01, @@ -13,7 +12,7 @@ "echo_level" : 0 }, "solver_settings" : { - "solver_type" : "solid_mechanics_implicit_dynamic_solver", + "solver_type" : "structural_mechanics_implicit_dynamic_solver", "echo_level" : 0, "solution_type" : "Dynamic", "time_integration_method" : "Implicit", @@ -23,6 +22,9 @@ "input_filename" : "mmg_lagrangian_test/beam2D_test", "input_file_label" : 0 }, + "material_import_settings" :{ + "materials_filename": "mmg_lagrangian_test/materials_2D.json" + }, "line_search" : false, "convergence_criterion" : "Residual_criterion", "displacement_relative_tolerance" : 0.0001, @@ -38,10 +40,10 @@ "processes_sub_model_part_list" : ["Parts_Parts_Auto1","DISPLACEMENT_Displacement_Auto1","SelfWeight2D_Self_weight_Auto1"] }, "constraints_process_list" : [{ - "python_module" : "assign_vector_components_to_nodes_process", - "kratos_module" : "KratosMultiphysics.SolidMechanicsApplication", + "python_module" : "assign_vector_variable_process", + "kratos_module" : "KratosMultiphysics", "help" : "This process fixes the selected components of a given vector variable", - "process_name" : "AssignVectorComponentsToNodesProcess", + "process_name" : "AssignVectorProcess", "Parameters" : { "mesh_id" : 0, "model_part_name" : "DISPLACEMENT_Displacement_Auto1", @@ -51,17 +53,16 @@ } }], "loads_process_list" : [{ - "python_module" : "assign_modulus_and_direction_to_nodes_process", - "kratos_module" : "KratosMultiphysics.SolidMechanicsApplication", + "python_module" : "assign_vector_variable_process", + "kratos_module" : "KratosMultiphysics", "help" : "This process fixes all the components of a given vector variable", "check" : "DirectorVectorNonZero direction", - "process_name" : "AssignModulusAndDirectionToNodesProcess", + "process_name" : "AssignVectorProcess", "Parameters" : { "mesh_id" : 0, "model_part_name" : "SelfWeight2D_Self_weight_Auto1", "variable_name" : "VOLUME_ACCELERATION", - "modulus" : 9.81, - "direction" : [0.0,-1.0,0.0], + "value" : [0.0,-9.81,0.0], "interval" : [0.0,"End"] } }], @@ -138,8 +139,12 @@ "help" : "This process compares two files and executes an Unittest Assert", "process_name" : "CompareTwoFilesCheckProcess", "Parameters" : { - "file_name_1" : "mmg_lagrangian_test/beam2D_test_step=10.o.mesh", - "file_name_2" : "mmg_lagrangian_test/beam2D_test_result.mesh" + "file_name_1" : "mmg_lagrangian_test/beam2D_test_step=10.sol", + "file_name_2" : "mmg_lagrangian_test/beam2D_test_result.sol", + "deterministic" : false, + "error_assumed" : 1.0e-6, + "dimension" : 2, + "non_deterministic_comp" : "sol_file" } } ] diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_result.mesh b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_result.mesh deleted file mode 100644 index 9fbdf0af4a5c..000000000000 --- a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_result.mesh +++ /dev/null @@ -1,952 +0,0 @@ -MeshVersionFormatted 2 - - -Dimension 2 - - -Vertices -309 -0 1 6 -0.250017164722982 0.999989890043932 7 -0 0.75 6 -0.338469281418486 0.763951599572478 7 -0.209676334199133 0.586615575843017 7 -0.500037046314461 0.999974270055711 7 -0 0.5 6 -0.218349885623766 0.405055068763229 7 -0.616067775898784 0.75231901190667 7 -0.45501621157261 0.494783451687298 7 -0.750055696965577 0.999949291207955 7 -0 0.25 6 -0.374984050540671 0.216752312777906 7 -0.742500911157707 0.488011688268216 7 -0.873529043762148 0.738514884896006 7 -0 0 6 -1.00007313481315 0.999915383583858 7 -0.624974186453931 0.216732095658529 7 -0.249983257927549 -1.04571640768322e-05 7 -0.499963282316553 -2.57171587791129e-05 7 -0.999990162160039 0.433450381576145 7 -1.12482740685416 0.724334006085045 7 -0.87496459842357 0.216702363456326 7 -0.749944808807739 -5.05490714406923e-05 7 -1.25008895552295 0.999873111544208 7 -1.12495473010147 0.216664092269574 7 -1.24998850242359 0.433407844954607 7 -1.37504413313628 0.731389584612489 7 -0.999927420268425 -8.46045328636554e-05 7 -1.50010425096202 0.999823039931664 7 -1.37494545530498 0.216617579829841 7 -1.49999365269597 0.467420652881369 7 -1.24991087414865 -0.000126773170676145 7 -1.62505288891551 0.738721256099368 7 -1.75011896555387 0.999765590105022 7 -1.49989535816043 -0.000176778466562446 7 -1.62493708268876 0.216563440690329 7 -1.74999273368154 0.467806340844308 7 -1.87505786360709 0.731274213447453 7 -2.00013259317843 0.999701062104055 7 -1.74988078984326 -0.000234382509792366 7 -1.93632206867596 0.196284045713085 7 -1.99999248349088 0.470402858273057 7 -2.12506622160093 0.73879691464004 7 -1.99986705610233 -0.000298968657302908 7 -2.25014553340941 0.999629917035559 7 -2.12492142330092 0.21643395672259 7 -2.24999619850762 0.486094494523339 7 -2.3750752995485 0.74860415176034 7 -2.24985414388918 -0.000370083869050897 7 -2.50015781546329 0.99955255004991 7 -2.37491439255346 0.216359423291243 7 -2.49999537655735 0.484785830358672 7 -2.6250812520525 0.74873438959291 7 -2.49984202282468 -0.000447478219087346 7 -2.62490774555755 0.216278870854008 7 -2.75016919959677 0.999469319341207 7 -2.74999254539971 0.477316550821857 7 -2.87508720882658 0.749914254184931 7 -2.74983062976636 -0.000530740021848617 7 -2.8749014077168 0.216192652973673 7 -3.0001797476084 0.999380676582101 7 -2.99999726907807 0.491999059762977 7 -3.12510442558329 0.782573078465103 7 -2.99981998241857 -0.000619359948356843 7 -3.13251749563763 0.209303777288211 7 -3.25019015098241 0.999286852597038 7 -3.2499917091377 0.477133418916605 7 -3.37509661640701 0.748933173141885 7 -3.24981001048791 -0.000713235668246929 7 -3.37489015488128 0.216004709743923 7 -3.50019927615169 0.999188174202399 7 -3.49999420065416 0.484420340027325 7 -3.62510204677046 0.750986286315454 7 -3.49980073869223 -0.000811841466687195 7 -3.6248850669357 0.215903670726995 7 -3.75020791282661 0.999085140452342 7 -3.7499974254624 0.492933754759789 7 -3.74979214169566 -0.000914838824152663 7 -3.87510500643391 0.747803597622998 7 -3.8748804324673 0.215798380858158 7 -4.0002159503329 0.998978014486797 7 -3.9999903925486 0.476823892363093 7 -3.99978417235507 -0.00102199371913832 7 -4.12510397447623 0.736615745598964 7 -4.12487604473374 0.215689162111852 7 -4.25022327973713 0.998867069840983 7 -4.24998616227787 0.467890853601981 7 -4.24977678090715 -0.00113291306392856 7 -4.37510460320792 0.730348084077728 7 -4.37487197266148 0.215576300562799 7 -4.50023000000065 0.99875267527419 7 -4.49998517197537 0.466511050663641 7 -4.49976996738329 -0.0012473161387531 7 -4.62511108327649 0.737617592986701 7 -4.62486825060805 0.215460093540166 7 -4.75023629422718 0.998635055790214 7 -4.7499847016085 0.46618233471613 7 -4.74976371689671 -0.00136494220862286 7 -4.87511040318057 0.730112570998369 7 -4.87486485767291 0.215340800433128 7 -5.00024200865289 0.998514463981699 7 -4.99998289112859 0.463113333544871 7 -4.99975801401829 -0.00148552358778536 7 -5.1251080539928 0.719897771774997 7 -5.12486175408611 0.215218710194483 7 -5.25024714333912 0.998391209199693 7 -5.24998207593171 0.46225346595737 7 -5.2497528324595 -0.00160875369067563 7 -5.37511464070259 0.728395497395816 7 -5.37485896711635 0.215094103822623 7 -5.50025185673417 0.998265572884813 7 -5.49996651688278 0.431795569491097 7 -5.49974811964345 -0.00173443570785875 7 -5.6251166680962 0.728302736179101 7 -5.62485636808179 0.214967194503045 7 -5.75025607927745 0.998137692916395 7 -5.74996603407944 0.431667520516729 7 -5.74974385496261 -0.00186227964966313 7 -5.8751186166682 0.728378877741711 7 -5.87485406783434 0.214838194380468 7 -6.00025985326942 0.998007858172657 7 -5.99996557459297 0.431537518600806 7 -5.99974003879095 -0.00199211257776593 7 -6.12512092048581 0.729478967240592 7 -6.12485201139701 0.21470734347773 7 -6.25026319959832 0.997876290197684 7 -6.24996517897947 0.431405781124824 7 -6.24973663795084 -0.00212371893098984 7 -6.37512628789139 0.736732210907757 7 -6.37485014826399 0.214574830135543 7 -6.50026617623882 0.997743145267526 7 -6.49998909268772 0.477023176394854 7 -6.49973365576705 -0.00225683657893758 7 -6.62513255770836 0.745659500022534 7 -6.62484858473078 0.214440889768265 7 -6.75026879007477 0.997608702983285 7 -6.74999274882204 0.484069135747289 7 -6.74973106300212 -0.00239132231316207 7 -6.87515281347455 0.780777549402738 7 -6.87484721365863 0.214305711032193 7 -7.00027113689438 0.997473048295075 7 -6.99999201357725 0.482702368980307 7 -6.99972881004629 -0.00252698031521726 7 -7.12515397594772 0.78064125618007 7 -7.12484602499663 0.214169434397638 7 -7.25027308878942 0.997336362836347 7 -7.24998793718474 0.475179811860131 7 -7.24972687873431 -0.00266365944476968 7 -7.37515496796519 0.780504044442874 7 -7.37484499219293 0.214032232298836 7 -7.5002747172661 0.997198824796504 7 -7.49999715542931 0.491967863180192 7 -7.49972525291955 -0.00280117427082765 7 -7.62515583017113 0.780366076325426 7 -7.62484414848408 0.213894264158008 7 -7.75027606322683 0.997060608939556 7 -7.74999492908678 0.48782891500551 7 -7.7497239112051 -0.00293940110379204 7 -7.87515652635758 0.780227488299399 7 -7.87484344047741 0.213755674017644 7 -8.00027715272937 0.996921822492227 7 -8.00000614400483 0.508000864705214 7 -7.99972282930594 -0.0030781768689942 7 -8.12515710397446 0.780088411656171 7 -8.12484288953813 0.213616595864711 7 -8.25027801223238 0.996782611430666 7 -8.24999999619454 0.49678292246985 7 -8.24972198044408 -0.003217397886676 7 -8.37515753886366 0.779948960471528 7 -8.37484244861583 0.213477147318888 7 -8.50027866788786 0.996643057015031 7 -8.49999862658855 0.494181380640586 7 -8.49972133517182 -0.00335693934450671 7 -8.6252419208194 0.74917617895104 7 -8.62484211757265 0.213337430126964 7 -8.75027912505799 0.996503291564268 7 -8.74999175204772 0.481731953925299 7 -8.74972086981332 -0.00349670793771154 7 -8.87574613933878 0.746047955689403 7 -8.87484187549314 0.213197542567696 7 -9.00027943302961 0.99636338537929 7 -8.99998761931236 0.474206232360781 7 -8.99972055557451 -0.00363661407341421 7 -9.12878127344619 0.747673353567568 7 -9.12484171269766 0.213057558297366 7 -9.25027962000154 0.996223410110084 7 -9.25749350956651 0.48959499678039 7 -9.24972036721289 -0.00377658848237316 7 -9.38948953438256 0.74998262211423 7 -9.37484161801495 0.21291754329374 7 -9.50027971418477 0.996083422783518 7 -9.49972027439954 -0.00391657799144174 7 -9.54497345602646 0.478469841751597 7 -9.65875274666352 0.759994682712672 7 -9.65989798641484 0.221440718043731 7 -9.75027974322855 0.995943462657728 7 -9.78168541531097 0.564278585412708 7 -9.74972024644161 -0.00405653824226955 7 -9.77377727548531 0.411383054077887 7 -10.0002797506841 0.995803550114043 7 -10.0001398555757 0.745803554881525 7 -9.99999999657739 0.495803565140231 7 -9.99986013567536 0.245803553513007 7 -9.99972023915036 -0.00419645141913809 7 -0.124991628963775 0.124994771417962 0 -0.37497327018118 -1.71887367785874e-05 7 -0.624954045678426 -3.69584139668323e-05 7 -0.874936114684489 -6.6493272864101e-05 7 -1.12491914737642 -0.000104692007041093 7 -1.37490311634728 -0.000150811130437004 7 -1.62488807421127 -0.000204669210494886 7 -1.87487392319058 -0.000265831162255301 7 -9.87479019105849 0.120873507635369 0 -9.87520979940213 0.870873508769627 0 -2.54382171767819 0.873418770430442 0 -2.31261041647896 0.87411703439795 0 -2.06259940738968 0.869248988372048 0 -1.81258841458048 0.865519901776237 0 -1.6251116084653 0.99979521856695 7 -1.37509660343207 0.999849024363454 7 -1.1250810453383 0.999895257834743 7 -0.87506441603534 0.999933418244705 7 -0.625046371753721 0.999962923624237 7 -0.375027105580356 0.999983009353057 7 -0.125008582361491 0.874994945021966 0 -0.562468734385242 0.108353189249875 0 -0.53999519901327 0.355757773672914 0 -0.260921339911892 0.162096703628021 0 -0.812454703615655 0.108325907192443 0 -0.808732754790639 0.352357025862271 0 -1.06244107518495 0.108289743868355 0 -1.06247244613075 0.325057236922859 0 -1.31242816472682 0.108245403329583 0 -1.31246697886429 0.325012712392224 0 -1.5624162204246 0.108193331111883 0 -1.56246536769237 0.341992046785849 0 -1.81240492181678 0.108133854647923 0 -1.81246089373592 0.342154216324974 0 -2.0624569533959 0.343418407497823 0 -2.31245529553054 0.351226958907291 0 -2.56245156105745 0.35053235060634 0 -2.81244697655826 0.346754601897765 0 -3.04623716841438 0.351563515002586 0 -0.641248055085489 0.421884730970565 0 -0.679284343528246 0.620165350087443 0 -0.336683048598188 0.449919260225264 0 -0.296666968082219 0.310903690770567 0 -1.93752517354898 0.600838535860255 0 -1.62499319318876 0.467613496862839 0 -1.62502304105213 0.603167376481104 0 -2.68753689872611 0.613025470207383 0 -2.43753533805293 0.616694991059506 0 -3.17126088473115 0.627184193210727 0 -2.93754223895233 0.620956656973954 0 -1.43757419204915 0.865606312272077 0 -1.43751889291613 0.599405118746929 0 -1.7500553762613 0.734997734773411 0 -1.75002405497142 0.60140203780886 0 -1.18745818118855 0.862103558814626 0 -1.18740795463887 0.578870925519826 0 -0.936927516402571 0.873931644014001 0 -0.936886030076015 0.590699143010144 0 -0.68306173643218 0.876134151557313 0 -0.767279607342155 0.702415106233058 0 -0.419253163866474 0.881962934814095 0 -0.396742746495548 0.629367525629888 0 -0.294243223070734 0.881970744808205 0 -2.18753121005427 0.61244570458169 0 -0.169234640709243 0.756975799786239 0 -0.871245536658873 0.460731034922181 0 -1.12498933229182 0.433429113265376 0 -1.37499107755978 0.450414248917988 0 -0.437473666428612 0.108363297809563 0 -0.687459497630835 0.108340773293544 0 -0.937446009345998 0.108308879461731 0 -1.18743280212506 0.108268659549449 0 -1.43742040673271 0.108220400681639 0 -1.68740893626601 0.108164529090268 0 -1.56257856993876 0.869272148015516 0 -1.31251618661885 0.863854935543351 0 -1.06219284879556 0.868017601414313 0 -0.807492395443028 0.866983331461741 0 -0.551157450149327 0.879048543185704 0 -0.499979118497301 0.216742204218217 0 -0.74996939243875 0.216717229557428 0 -0.999959664262519 0.21668322786295 0 -0.937477380291805 0.325076372516236 0 -1.24995009270323 0.216640836049707 0 -1.18747161626253 0.32503596861209 0 -1.49994126899687 0.216590510260085 0 -1.43746955400048 0.342019116355605 0 -1.74993306823953 0.216532766247984 0 -1.68746313071414 0.342073131555411 0 -9.82844760735655 0.717576047091167 0 -0.538013545011897 0.624766437858666 0 -0.148333484041109 0.280451845385284 0 -9.83253115121511 0.260150056499164 0 -1.5000485110259 0.735055420355929 0 -1.24993576999522 0.727861795348767 0 -0.999304652423074 0.736140955264594 0 -1.06214699235744 0.584785034264985 0 -0.477268528658635 0.758135305739574 0 -0.823889328709495 0.572393831093987 0 -1.3124634237775 0.589138022133378 0 -1.68758592723469 0.869243423102195 0 -0.588587396381655 0.517664014932484 0 -0.69560872376212 0.319300980263996 0 -0.418331083547744 0.33333073222174 0 - - -Corners -4 -1 -16 -201 -205 - - -Edges -101 -162 157 0 -16 12 0 -16 19 0 -19 207 0 -20 208 0 -24 209 0 -29 210 0 -33 211 0 -36 212 0 -41 213 0 -45 50 0 -50 55 0 -55 60 0 -60 65 0 -65 70 0 -70 75 0 -75 79 0 -79 84 0 -84 89 0 -89 94 0 -94 99 0 -99 104 0 -104 109 0 -109 114 0 -124 129 0 -114 119 0 -119 124 0 -129 134 0 -134 139 0 -139 144 0 -144 149 0 -149 154 0 -154 159 0 -159 164 0 -164 169 0 -169 174 0 -174 179 0 -179 184 0 -184 189 0 -189 193 0 -193 199 0 -205 204 0 -199 205 0 -204 203 0 -203 202 0 -201 197 0 -202 201 0 -197 192 0 -192 187 0 -187 182 0 -182 177 0 -177 172 0 -172 167 0 -167 162 0 -157 152 0 -152 147 0 -147 142 0 -142 137 0 -137 132 0 -82 77 0 -132 127 0 -127 122 0 -122 117 0 -117 112 0 -112 107 0 -107 102 0 -102 97 0 -97 92 0 -92 87 0 -87 82 0 -77 72 0 -72 67 0 -67 62 0 -62 57 0 -57 51 0 -51 46 0 -46 40 0 -40 35 0 -35 220 0 -30 221 0 -25 222 0 -17 223 0 -11 224 0 -6 225 0 -1 3 0 -2 1 0 -3 7 0 -7 12 0 -207 20 0 -208 24 0 -209 29 0 -210 33 0 -211 36 0 -212 41 0 -213 45 0 -220 30 0 -221 25 0 -222 17 0 -223 11 0 -224 6 0 -225 2 0 - - -Triangles -515 -162 157 160 5 -12 16 206 5 -13 229 274 5 -18 227 275 5 -23 230 276 5 -26 232 277 5 -31 234 278 5 -37 236 279 5 -45 42 213 5 -45 50 47 5 -50 55 52 5 -55 60 56 5 -60 65 61 5 -65 70 66 5 -70 75 71 5 -75 79 76 5 -79 84 81 5 -84 89 86 5 -89 94 91 5 -94 99 96 5 -99 104 101 5 -104 109 106 5 -109 114 111 5 -124 129 126 5 -114 119 116 5 -119 124 121 5 -129 134 131 5 -134 139 136 5 -139 144 141 5 -144 149 146 5 -149 154 151 5 -154 159 156 5 -159 164 161 5 -164 169 166 5 -169 174 171 5 -174 179 176 5 -179 184 181 5 -184 189 186 5 -189 193 191 5 -193 199 196 5 -199 205 214 5 -298 203 200 5 -203 202 295 5 -202 201 215 5 -197 192 195 5 -192 187 190 5 -187 182 185 5 -182 177 180 5 -177 172 175 5 -172 167 170 5 -167 162 165 5 -157 152 155 5 -152 147 150 5 -147 142 145 5 -142 137 140 5 -137 132 135 5 -82 77 80 5 -132 127 130 5 -127 122 125 5 -122 117 120 5 -117 112 115 5 -112 107 110 5 -107 102 105 5 -102 97 100 5 -97 92 95 5 -92 87 90 5 -87 82 85 5 -77 72 74 5 -72 67 69 5 -67 62 64 5 -62 57 59 5 -54 57 216 5 -49 216 217 5 -44 217 218 5 -39 218 219 5 -34 306 280 5 -256 221 281 5 -260 222 282 5 -262 223 283 5 -264 224 284 5 -2 268 225 5 -2 1 226 5 -3 7 5 5 -7 12 297 5 -160 157 155 5 -160 155 158 5 -162 160 165 5 -165 160 163 5 -126 129 131 5 -126 131 128 5 -13 274 285 5 -10 247 309 5 -13 248 229 5 -18 275 286 5 -14 245 308 5 -23 276 287 5 -23 287 288 5 -26 277 289 5 -26 289 290 5 -31 278 291 5 -31 291 292 5 -37 279 293 5 -239 38 294 5 -42 45 47 5 -43 239 240 5 -47 50 52 5 -48 240 241 5 -52 55 56 5 -53 241 242 5 -56 60 61 5 -58 242 243 5 -61 65 66 5 -63 243 244 5 -66 70 71 5 -66 71 68 5 -76 79 81 5 -76 81 78 5 -116 119 121 5 -116 121 118 5 -151 154 156 5 -151 156 153 5 -151 153 148 5 -71 75 76 5 -71 76 73 5 -94 96 91 5 -91 96 93 5 -81 84 86 5 -81 86 83 5 -86 89 91 5 -86 91 88 5 -96 99 101 5 -96 101 98 5 -101 104 106 5 -101 106 103 5 -106 109 111 5 -106 111 108 5 -111 114 116 5 -111 116 113 5 -121 124 126 5 -121 126 123 5 -131 134 136 5 -131 136 133 5 -141 144 146 5 -141 146 143 5 -146 149 151 5 -146 151 148 5 -146 148 143 5 -143 148 145 5 -161 164 166 5 -161 166 163 5 -159 161 156 5 -156 161 158 5 -166 169 171 5 -166 171 168 5 -171 174 176 5 -171 176 173 5 -176 179 181 5 -176 181 178 5 -181 184 186 5 -181 186 183 5 -186 189 191 5 -186 191 188 5 -191 193 196 5 -191 196 194 5 -199 214 196 5 -215 195 295 5 -185 182 180 5 -185 180 183 5 -187 185 190 5 -190 185 188 5 -180 177 175 5 -180 175 178 5 -175 172 170 5 -175 170 173 5 -170 167 165 5 -170 165 168 5 -132 130 135 5 -135 130 133 5 -125 122 120 5 -125 120 123 5 -112 110 115 5 -115 110 113 5 -105 102 100 5 -105 100 103 5 -107 105 110 5 -110 105 108 5 -100 97 95 5 -100 95 98 5 -95 92 90 5 -95 90 93 5 -90 87 85 5 -90 85 88 5 -14 246 307 5 -246 9 296 5 -8 248 247 5 -248 8 297 5 -136 139 141 5 -136 141 138 5 -80 77 74 5 -80 74 78 5 -85 82 80 5 -85 80 83 5 -74 72 69 5 -74 69 73 5 -44 218 39 5 -43 269 249 5 -32 237 250 5 -34 299 251 5 -53 242 58 5 -54 253 252 5 -48 241 53 5 -49 269 253 5 -63 244 68 5 -64 255 254 5 -76 78 73 5 -73 78 74 5 -118 121 123 5 -118 123 120 5 -58 243 63 5 -59 252 255 5 -186 188 183 5 -183 188 185 5 -200 203 198 5 -200 198 194 5 -200 196 298 5 -196 200 194 5 -215 295 202 5 -198 195 194 5 -195 192 190 5 -195 190 194 5 -155 152 150 5 -155 150 153 5 -150 147 145 5 -150 145 148 5 -150 148 153 5 -145 142 140 5 -145 140 143 5 -140 137 135 5 -140 135 138 5 -117 115 120 5 -120 115 118 5 -69 67 64 5 -64 254 69 5 -34 280 299 5 -32 251 257 5 -39 219 258 5 -38 249 259 5 -28 281 300 5 -27 273 305 5 -22 282 301 5 -263 21 302 5 -9 265 264 5 -15 283 265 5 -9 284 303 5 -296 10 307 5 -2 226 268 5 -43 240 48 5 -44 249 269 5 -173 176 178 5 -173 178 175 5 -171 173 168 5 -168 173 170 5 -178 181 183 5 -178 183 180 5 -130 127 125 5 -130 125 128 5 -64 62 59 5 -59 255 64 5 -59 57 54 5 -54 252 59 5 -54 216 49 5 -49 253 54 5 -49 217 44 5 -44 269 49 5 -5 7 8 5 -8 247 5 5 -3 5 270 5 -247 267 5 5 -158 155 153 5 -158 153 156 5 -160 158 163 5 -163 158 161 5 -126 128 123 5 -123 128 125 5 -165 163 168 5 -168 163 166 5 -128 131 133 5 -128 133 130 5 -14 231 271 5 -271 263 304 5 -21 233 272 5 -302 272 261 5 -27 235 273 5 -261 27 305 5 -38 239 43 5 -43 249 38 5 -68 71 73 5 -68 73 69 5 -78 81 83 5 -78 83 80 5 -116 118 113 5 -113 118 115 5 -88 91 93 5 -88 93 90 5 -86 88 83 5 -83 88 85 5 -133 136 138 5 -133 138 135 5 -141 143 138 5 -138 143 140 5 -93 96 98 5 -93 98 95 5 -98 101 103 5 -98 103 100 5 -103 106 108 5 -103 108 105 5 -108 111 113 5 -108 113 110 5 -188 191 194 5 -188 194 190 5 -206 16 19 5 -207 229 19 5 -207 274 229 5 -275 227 208 5 -276 230 209 5 -277 232 210 5 -278 234 211 5 -279 236 212 5 -42 238 213 5 -214 205 204 5 -203 298 204 5 -215 201 197 5 -215 197 195 5 -216 57 51 5 -216 51 217 5 -217 51 46 5 -217 46 218 5 -218 46 40 5 -218 40 219 5 -219 40 35 5 -34 258 306 5 -280 306 220 5 -25 281 221 5 -17 282 222 5 -11 283 223 5 -6 284 224 5 -268 266 225 5 -226 1 3 5 -3 270 226 5 -285 274 227 5 -227 20 208 5 -309 285 228 5 -245 228 308 5 -229 297 206 5 -229 206 19 5 -286 275 230 5 -230 24 209 5 -14 308 231 5 -23 288 231 5 -287 276 232 5 -232 29 210 5 -288 287 233 5 -26 290 233 5 -289 277 234 5 -234 33 211 5 -290 289 235 5 -235 292 273 5 -291 278 236 5 -236 36 212 5 -292 291 237 5 -293 294 37 5 -293 279 238 5 -238 41 213 5 -294 293 239 5 -239 42 240 5 -240 42 47 5 -240 47 241 5 -241 47 52 5 -241 52 242 5 -242 52 56 5 -242 56 243 5 -243 56 61 5 -243 61 244 5 -244 61 66 5 -244 66 68 5 -245 307 228 5 -308 228 18 5 -296 307 246 5 -271 304 14 5 -228 10 309 5 -247 10 267 5 -248 297 229 5 -285 309 13 5 -249 44 39 5 -249 39 259 5 -250 237 294 5 -259 251 38 5 -251 32 250 5 -251 250 38 5 -252 53 58 5 -252 58 255 5 -253 48 53 5 -253 53 252 5 -254 63 68 5 -254 68 69 5 -255 58 63 5 -255 63 254 5 -299 280 256 5 -256 30 221 5 -251 299 257 5 -300 305 28 5 -258 219 306 5 -251 259 34 5 -259 39 258 5 -259 258 34 5 -256 281 28 5 -260 25 222 5 -305 300 261 5 -301 302 22 5 -260 282 22 5 -262 17 223 5 -302 301 263 5 -304 15 265 5 -262 283 15 5 -264 11 224 5 -265 9 246 5 -304 246 14 5 -264 284 9 5 -266 6 225 5 -296 303 267 5 -267 4 5 5 -268 226 270 5 -268 4 266 5 -269 43 48 5 -269 48 253 5 -270 5 4 5 -270 4 268 5 -271 231 288 5 -271 21 263 5 -272 233 290 5 -272 27 261 5 -292 235 31 5 -273 32 257 5 -274 207 20 5 -274 20 227 5 -275 208 24 5 -275 24 230 5 -276 209 29 5 -276 29 232 5 -277 210 33 5 -277 33 234 5 -278 211 36 5 -278 36 236 5 -279 212 41 5 -279 41 238 5 -280 220 30 5 -280 30 256 5 -281 25 260 5 -281 260 300 5 -282 17 262 5 -282 262 301 5 -283 11 264 5 -283 264 265 5 -284 6 266 5 -284 266 303 5 -285 227 18 5 -285 18 228 5 -286 230 23 5 -286 23 231 5 -287 232 26 5 -287 26 233 5 -288 233 21 5 -288 21 271 5 -289 234 31 5 -289 31 235 5 -290 235 27 5 -290 27 272 5 -291 236 37 5 -291 37 237 5 -292 237 32 5 -292 32 273 5 -293 238 42 5 -293 42 239 5 -294 38 250 5 -294 237 37 5 -295 195 198 5 -295 198 203 5 -296 9 303 5 -296 267 10 5 -297 8 7 5 -297 12 206 5 -298 196 214 5 -298 214 204 5 -299 256 28 5 -299 28 257 5 -300 260 22 5 -300 22 261 5 -301 262 15 5 -301 15 263 5 -302 21 272 5 -302 261 22 5 -303 266 4 5 -303 4 267 5 -304 263 15 5 -304 265 246 5 -305 273 257 5 -305 257 28 5 -306 219 35 5 -306 35 220 5 -307 10 228 5 -307 245 14 5 -308 18 286 5 -308 286 231 5 -309 247 248 5 -309 248 13 5 - - -End diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_result.sol b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_result.sol new file mode 100644 index 000000000000..20f96b5a998b --- /dev/null +++ b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam2D_test_result.sol @@ -0,0 +1,217 @@ +MeshVersionFormatted 2 + + +Dimension 2 + + +SolAtVertices +205 +1 3 +16.2448121764785 0 16.2448121764785 +26.3671185698288 0 26.3671185698288 +23.2212205217394 0 23.2212205217394 +37.4246612020474 0 37.4246612020474 +32.1119867032019 0 32.1119867032019 +44.2166785720013 0 44.2166785720013 +26.839631180711 0 26.839631180711 +32.0932169705514 0 32.0932169705514 +43.3576271908685 0 43.3576271908685 +46.2808019174149 0 46.2808019174149 +44.9182760766853 0 44.9182760766853 +21.097206119284 0 21.097206119284 +36.8120075425353 0 36.8120075425353 +40.8884810824339 0 40.8884810824339 +39.7068796253869 0 39.7068796253869 +16.2448121764785 0 16.2448121764785 +38.1282017121372 0 38.1282017121372 +44.5804468567627 0 44.5804468567627 +26.3727655228199 0 26.3727655228199 +47.8553928048633 0 47.8553928048633 +39.8864789596783 0 39.8864789596783 +35.9699402807709 0 35.9699402807709 +39.4745921471389 0 39.4745921471389 +40.6527196394298 0 40.6527196394298 +34.7387041150555 0 34.7387041150555 +37.6468860127406 0 37.6468860127406 +37.3802694276059 0 37.3802694276059 +34.3954620528457 0 34.3954620528457 +37.913169012117 0 37.913169012117 +33.8154424590953 0 33.8154424590953 +35.0765762700086 0 35.0765762700086 +33.5366583026979 0 33.5366583026979 +37.2923970350899 0 37.2923970350899 +32.8707805321133 0 32.8707805321133 +31.8218476020034 0 31.8218476020034 +35.0512210929899 0 35.0512210929899 +32.4999619543909 0 32.4999619543909 +31.6520434930733 0 31.6520434930733 +30.8870099569872 0 30.8870099569872 +29.9524538223571 0 29.9524538223571 +32.3853423133948 0 32.3853423133948 +30.6948363666217 0 30.6948363666217 +29.8009049765596 0 29.8009049765596 +29.7262133721813 0 29.7262133721813 +30.5567164350736 0 30.5567164350736 +29.0523752840688 0 29.0523752840688 +28.8520914884565 0 28.8520914884565 +27.9811940942754 0 27.9811940942754 +28.0156668610856 0 28.0156668610856 +28.542487851003 0 28.542487851003 +27.5021847049864 0 27.5021847049864 +27.0840682788817 0 27.0840682788817 +26.6414448488669 0 26.6414448488669 +25.782633947093 0 25.782633947093 +26.4023724415711 0 26.4023724415711 +25.4925388132297 0 25.4925388132297 +25.0488142507954 0 25.0488142507954 +24.9230806315501 0 24.9230806315501 +24.7720321435658 0 24.7720321435658 +24.9621186711489 0 24.9621186711489 +23.928805350409 0 23.928805350409 +25.239256347979 0 25.239256347979 +23.1904387711302 0 23.1904387711302 +22.7854886625282 0 22.7854886625282 +23.2636401088817 0 23.2636401088817 +22.2688703859572 0 22.2688703859572 +22.0582736350791 0 22.0582736350791 +21.7362991372384 0 21.7362991372384 +20.5507914307898 0 20.5507914307898 +21.7072547200026 0 21.7072547200026 +20.7636234107167 0 20.7636234107167 +19.6990677117846 0 19.6990677117846 +20.5611305841801 0 20.5611305841801 +19.2380446759792 0 19.2380446759792 +20.2808662030285 0 20.2808662030285 +19.1205777433239 0 19.1205777433239 +18.8083332839517 0 18.8083332839517 +18.8502201789757 0 18.8502201789757 +18.4985290207209 0 18.4985290207209 +17.8303488710591 0 17.8303488710591 +17.7117171905908 0 17.7117171905908 +17.4047209367289 0 17.4047209367289 +17.7617665053954 0 17.7617665053954 +17.1046481172202 0 17.1046481172202 +16.3037942269018 0 16.3037942269018 +16.4259335510944 0 16.4259335510944 +16.2448121764785 0 16.2448121764785 +16.2865307931596 0 16.2865307931596 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +18.7205507709553 0 18.7205507709553 +20.5438412754597 0 20.5438412754597 +16.2448121764785 0 16.2448121764785 +36.6973733711851 0 36.6973733711851 +16.973015160782 0 16.973015160782 +36.6973733711851 0 36.6973733711851 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 +19.1021657969756 0 19.1021657969756 +16.2448121764785 0 16.2448121764785 +16.2448121764785 0 16.2448121764785 + + +End diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_parameters.json b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_parameters.json index e3db87803945..7d96133c9d8b 100644 --- a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_parameters.json +++ b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_parameters.json @@ -12,7 +12,7 @@ "echo_level" : 0 }, "solver_settings" : { - "solver_type" : "solid_mechanics_implicit_dynamic_solver", + "solver_type" : "structural_mechanics_implicit_dynamic_solver", "echo_level" : 0, "solution_type" : "Dynamic", "time_integration_method" : "Implicit", @@ -22,6 +22,9 @@ "input_filename" : "mmg_lagrangian_test/beam3D_test", "input_file_label" : 0 }, + "material_import_settings" :{ + "materials_filename": "mmg_lagrangian_test/materials_3D.json" + }, "line_search" : false, "convergence_criterion" : "Residual_criterion", "displacement_relative_tolerance" : 0.0001, @@ -37,10 +40,10 @@ "processes_sub_model_part_list" : ["Parts_Parts_Auto1","DISPLACEMENT_Displacement_Auto1","SelfWeight3D_Self_weight_Auto1"] }, "constraints_process_list" : [{ - "python_module" : "assign_vector_components_to_nodes_process", - "kratos_module" : "KratosMultiphysics.SolidMechanicsApplication", + "python_module" : "assign_vector_variable_process", + "kratos_module" : "KratosMultiphysics", "help" : "This process fixes the selected components of a given vector variable", - "process_name" : "AssignVectorComponentsToNodesProcess", + "process_name" : "AssignVectorProcess", "Parameters" : { "mesh_id" : 0, "model_part_name" : "DISPLACEMENT_Displacement_Auto1", @@ -50,17 +53,16 @@ } }], "loads_process_list" : [{ - "python_module" : "assign_modulus_and_direction_to_nodes_process", - "kratos_module" : "KratosMultiphysics.SolidMechanicsApplication", + "python_module" : "assign_vector_variable_process", + "kratos_module" : "KratosMultiphysics", "help" : "This process fixes all the components of a given vector variable", "check" : "DirectorVectorNonZero direction", - "process_name" : "AssignModulusAndDirectionToNodesProcess", + "process_name" : "AssignVectorProcess", "Parameters" : { "mesh_id" : 0, "model_part_name" : "SelfWeight3D_Self_weight_Auto1", "variable_name" : "VOLUME_ACCELERATION", - "modulus" : 9.81, - "direction" : [0.0,0.0,-1.0], + "value" : [0.0,0.0,-9.81], "interval" : [0.0,"End"] } }], @@ -130,17 +132,18 @@ } } ], - "_compare_two_files_check_process" :[ + "compare_two_files_check_process" :[ { "python_module" : "compare_two_files_check_process", "kratos_module" : "KratosMultiphysics", "help" : "This process compares two files and executes an Unittest Assert", "process_name" : "CompareTwoFilesCheckProcess", "Parameters" : { - "file_name_1" : "mmg_lagrangian_test/beam3D_test_step=3.o.mesh", - "file_name_2" : "mmg_lagrangian_test/beam3D_test_result.mesh", + "file_name_1" : "mmg_lagrangian_test/beam3D_test_step=3.sol", + "file_name_2" : "mmg_lagrangian_test/beam3D_test_result.sol", "deterministic" : false, - "error_assumed" : 1.0e-6 + "error_assumed" : 5.0e-2, + "non_deterministic_comp" : "sol_file" } } ] diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_result.mesh b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_result.mesh deleted file mode 100644 index b113b0d0aef1..000000000000 --- a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_result.mesh +++ /dev/null @@ -1,5564 +0,0 @@ -MeshVersionFormatted 2 - - -Dimension 3 - - -Vertices -739 -10 1 1 5 -10 0.5 1 5 -9.47998450282686 0.999996518830049 0.999987406278548 6 -10 0.999999988513214 0.499999999999965 5 -9.73909486979257 0.517010428235983 0.688626518074627 6 -9.65245774575656 0.740948938633411 0.303966587843251 6 -9.30861568192161 0.515605177682193 0.999979819891313 6 -9.26629010868602 0.999999803912393 0.57845515326989 6 -9.28847432695644 0.470107077652107 0.496833725223591 6 -10 1 0 5 -10 0 1 5 -8.98551349989532 0.999996374884972 0.999961875826091 6 -9.68031486504671 0.298987173088965 0.2989831183116 6 -10 0.5 0 5 -9.47701637849466 1.0000037076653 -1.13772508944009e-05 6 -9.51468202220078 2.19491225715393e-06 0.999988104684001 6 -10 -5.87408298020874e-08 0.475000000000091 5 -8.83611039935582 0.745449178793199 0.71896048988507 6 -9.26188697077859 0.461899416822873 -2.29633822086042e-05 6 -9.28375551340349 1.2496705911136e-07 0.401304107215696 6 -8.84291568551108 0.446709494038979 0.497575079255124 6 -8.81849068416487 1.00000110922795 0.439148255297612 6 -8.69679409392165 0.506412879356361 0.99993735173893 6 -10 0 0 5 -9.0152367486648 1.0000043925009 -3.62646069711821e-05 6 -9.09497090812332 3.51597816771892e-06 0.999968702308112 6 -9.42221176895111 -3.09983116074286e-06 -1.31807416842902e-05 6 -8.40328325001862 0.999997790938188 0.999912089915524 6 -8.78378187729816 6.2380384356445e-07 0.488574463444898 6 -8.69566668644021 0.435769288735972 -6.25017341862996e-05 6 -9.12697694980124 -2.59465712100173e-06 -2.94635167211572e-05 6 -8.50001040091509 0.289019617761582 0.372599154289146 6 -8.30105578935271 0.579378978574734 0.548630803039968 6 -8.36764942101459 1.00000465070344 -9.17119385183962e-05 6 -8.55630536840497 3.53663855533243e-06 0.999925545779837 6 -8.12815540186111 0.410376501785947 0.999880495996489 6 -8.32469130787926 1.0000013555651 0.526407387220362 6 -8.03720907712009 0.999997883896822 0.999871730914607 6 -7.96883268460468 0.793699024189642 0.746118920920567 6 -8.4550460842917 -1.14330025881607e-06 -8.37364883091317e-05 6 -8.21208289604991 0.665506940707642 -0.000110229143500593 6 -8.18176960009703 2.38761934945945e-06 0.659689182683926 6 -7.99834270682004 0.294071650242206 0.608985688773549 6 -7.98219961952788 0.668406290894393 0.284961655987209 6 -7.98776708671565 1.00000498853228 -0.000134172436791428 6 -7.99994241897866 3.95399643866533e-06 0.999867206164493 6 -7.63433544438141 1.00000225617507 0.470534910998553 6 -7.82885849468471 0.488800685210306 0.999845034785897 6 -8.1270034009449 -5.71996845342597e-07 -0.000119245624300401 6 -7.67929971987408 0.99999942352074 0.999827040084314 6 -7.67648750345287 0.455872637355624 -0.000174440685900854 6 -7.6366712765279 2.36831875216237e-06 0.554277726920162 6 -7.57512647619253 0.526700998543478 0.464927592218658 6 -7.54020945971481 0.250870414909207 0.706573299301997 6 -7.5847102673939 1.00000453007693 -0.000185007452464869 6 -7.44993175553949 3.77554792348971e-06 0.999795342566452 6 -7.46590822729182 0.260036491240824 0.236669584887522 6 -7.27620669474992 0.726828757655793 0.766595634373693 6 -7.14385418718383 0.546717257678311 0.999751108547196 6 -7.3103053179293 1.00000223613234 0.483887272201173 6 -7.45506702553735 6.85874550404943e-07 -0.000203495694484763 6 -7.30224692488827 0.338884475606942 -0.000226111156148646 6 -7.3571497190241 2.43541806321848e-06 0.596871809802086 6 -6.94992523625664 1.00000040676426 0.999723389529272 6 -7.05115185286604 0.382971672212958 0.594338617058136 6 -7.00003159032237 0.627324880806315 0.28874961190707 6 -6.90996558925445 0.765267143047402 0.781802223513012 6 -6.85507527952107 1.00000439629106 -0.000291667436898781 6 -6.99992586385731 3.29427804944427e-06 0.999730278783563 6 -6.73582029422906 0.440360246230509 0.999688548688768 6 -6.64009309571785 1.00000228552376 0.426666450428695 6 -7.00057384475736 1.09762147535656e-06 -0.000270398323109392 6 -6.68051469478864 0.605293797551454 -0.000319808808688695 6 -6.73656797567879 1.73177884283687e-06 0.260152515995118 6 -6.54492044341312 1.00000043855827 0.999659200067294 6 -6.45299639898532 0.551249673804843 0.51269594247945 6 -6.53095869755484 0.298339013502917 0.714117389834492 6 -6.45008021092879 1.00000353098241 -0.000356889150539412 6 -6.44436981575355 3.11368436263386e-06 0.999641549814189 6 -6.49762760279412 0.314066922901354 0.301698033281412 6 -6.49957994134061 1.58152826891017e-06 -0.000349099940408266 6 -6.23879125983477 0.510608808256142 0.999607613547955 6 -6.21249873442336 1.00000198823368 0.527424394194895 6 -6.20702947069433 0.525207487581113 -0.000397707160768412 6 -6.30155313093988 1.71986758118448e-06 0.342755488853257 6 -6.04991575130288 1.00000061060937 0.999576552434671 6 -6.01946683070263 0.469787030606548 0.597650502278618 6 -5.97317222944354 0.754923864422487 0.232124819912672 6 -5.90169492320845 0.737741861695258 0.749191831616679 6 -6.00008409122373 1.00000326183751 -0.000431844052519778 6 -5.94441550225791 2.27389503188129e-06 0.999557726213961 6 -6.0000844848961 1.46876730316687e-06 -0.000433026889517234 6 -5.72312847178373 0.527554798718981 0.999519088764583 6 -5.7323989412599 1.00000215787333 0.349547545957211 6 -5.7312616678657 0.538019236066183 -0.000479303337719316 6 -5.74224666876638 1.69953666028386e-06 0.343639524049338 6 -5.54991219582059 1.00000046247568 0.999489381250396 6 -5.51472707559456 0.69855584707998 0.608866696497953 6 -5.41903725977868 0.330707872367519 0.710877348147664 6 -5.47545189369829 0.328463677007862 0.326362712962938 6 -5.50008715044376 1.00000262067729 -0.00051956769256702 6 -5.44491240804969 1.98668829667315e-06 0.999469730583543 6 -5.50008793824317 1.45380633012678e-06 -0.000520251206776322 6 -5.26127749702626 1.00000175642858 0.360786540513356 6 -5.26174141183983 0.642761835252571 0.999437310608963 6 -5.24975987813793 0.486672366722912 -0.000565030364610569 6 -5.17761118393925 1.39137655347551e-06 0.337209033684238 6 -5.1483068388785 0.418395359102371 0.489905636575628 6 -4.9999097433603 1.0000006122019 0.999390602592874 6 -5.00008975131674 1.00000223690165 -0.000609420772082564 6 -4.9499100261504 1.18719828559819e-06 0.999380627954982 6 -4.99552643727504 0.709676329175378 0.286205308481069 6 -5.0000900792173 1.402399849544e-06 -0.000610329008781512 6 -4.73306417144456 0.577600048847696 0.597127263095885 6 -4.72579459158214 1.00000153781638 0.316478942729452 6 -4.61179856688942 0.297867644538556 0.999318911972592 6 -4.73006547248774 0.423918804421405 -0.000659352871242095 6 -4.70083529637697 1.341237668924e-06 0.338563198212728 6 -4.44990835095771 1.00000047751999 0.99928978981796 6 -4.54379186951297 0.241818324469473 0.742301598993461 6 -4.55673939084566 0.690554135912213 0.269822492692437 6 -4.48728162183344 0.308667102751208 0.328506867999884 6 -4.50009114659534 1.00000187865404 -0.000700953404954761 6 -4.44990871812724 9.79952873178661e-07 0.999288846958027 6 -4.34350405520442 0.599312854912689 0.502257886903641 6 -4.50009161286196 1.31584420141385e-06 -0.000701861336214384 6 -4.26121002154052 1.00000130018474 0.319337513631775 6 -4.14126188742795 0.331263706634736 0.999231991753245 6 -4.26130199772612 0.486004551433891 -0.000745647477663006 6 -4.21149914112873 1.03537950797002e-06 0.499810859879314 6 -3.94990748197149 1.00000029297213 0.99919719103127 6 -3.91516241195305 0.747200663697796 0.69338640221639 6 -3.99997651837973 0.289019659462295 0.626527890391744 6 -4.0113487387232 0.64268212070271 0.331837906464949 6 -4.09509191389795 1.00000158652177 -0.000775841802939688 6 -3.94490781601896 6.43927413503596e-07 0.999195387342529 6 -4.00009245977951 1.2794139036394e-06 -0.000794402550110142 6 -3.79864968510162 1.00000103308276 0.365652691624622 6 -3.79694383810701 0.644262006732648 0.999168402161812 6 -3.6780224080611 0.570207801151964 0.594293101841163 6 -3.78057217467431 0.470322485492268 -0.000834818437218709 6 -3.73476865960364 8.99075713487851e-07 0.420554590361997 6 -3.44490704907334 1.00000023572914 0.999103300741807 6 -3.48025714711286 0.29736326637617 0.388032314197585 6 -3.68604228512469 1.00000137179408 -0.0008518677310466 6 -3.39990745492464 2.73962974305652e-07 0.999094016965863 6 -3.40137946406408 0.695561507686669 0.236349114521666 6 -3.50009288486033 1.14478013617095e-06 -0.000887371573464517 6 -3.38591937400687 1.00000090528357 0.295774098544587 6 -3.41918150897451 0.393244581052926 0.999097931480084 6 -3.2087596648677 0.563907700415484 0.51577081876531 6 -3.26994669438039 0.38923230321886 -0.000929882942895549 6 -3.23677790244838 7.49093418819186e-07 0.367957961871667 6 -3.04320472929846 0.253582058349363 0.802058851741946 6 -2.89990698899051 1.0000000337706 0.99900188291057 6 -2.95189708120155 0.758504227114142 0.28964334004402 6 -2.97801666424944 0.264781474661677 0.364655100598371 6 -2.86953302886585 1.00000092574156 -0.00100377849108248 6 -2.94990739347563 5.97439873490399e-08 0.999010259995589 6 -3.00009297844752 9.79583153930994e-07 -0.000980421088816102 6 -2.86302416113996 0.567960961835478 0.542287621459452 6 -2.73959656882024 1.00000056333849 0.334552257213597 6 -2.67863236916242 0.309954511306852 0.998960118949456 6 -2.75168826747133 0.362499646233432 -0.00102627276932846 6 -2.77306490251549 4.54849756083038e-07 0.480014102125202 6 -2.3994070777888 0.99999985607901 0.99890891349562 6 -2.52963714933548 0.735484131084264 0.630421932149513 6 -2.50003904159303 0.627322515523702 0.287946010561419 6 -2.56387538365899 0.324999155315318 0.589363627937093 6 -2.44559247832774 1.00000073303923 -0.00108255024368838 6 -2.49990743686499 -1.59665434674489e-07 0.998926630338029 6 -2.50009289480016 8.03242058110129e-07 -0.00107333404077078 6 -2.27916508949098 1.00000035391071 0.360085797195645 6 -2.27742974713778 0.325594370615379 0.998885667773258 6 -2.23458431529076 0.325722751499635 -0.00112228490914679 6 -2.23864840544895 2.44194521546997e-07 0.478514293550283 6 -2.16117546007195 0.595890281494031 0.605897395547019 6 -1.94490721129498 0.999999685006031 0.998824662519214 6 -1.95009236305683 1.00000053423669 -0.00117440761404312 6 -1.99990758660903 -3.54454673773956e-07 0.998833934524532 6 -2.00009275431754 6.1586037569627e-07 -0.0011660438240603 6 -1.92047387277741 0.64549397980989 0.803524720553439 6 -1.78475540457061 1.00000019310014 0.331609167676962 6 -1.7889622326731 0.35271874324996 0.998795232516074 6 -1.74874662423298 0.473664148946276 -0.00121212774376614 6 -1.73130900929207 1.99862923601485e-07 0.324746568602343 6 -1.44990737105934 0.99999949901085 0.99873310589142 6 -1.45924027266896 0.731191213465388 0.688304015883554 6 -1.49995702917026 0.258960497042468 0.731570108698378 6 -1.50003904318396 0.372678135502756 0.287760581990205 6 -1.5000922303363 1.00000037397803 -0.00125762593936213 6 -1.49990773114836 -5.51785136712798e-07 0.99874144663681 6 -1.50009260275147 4.24870521653602e-07 -0.00125854357987313 6 -1.31098043716924 0.999999950970971 0.403108749803471 6 -1.27591352144841 0.326953969159609 0.998700376346177 6 -1.23553414942618 0.473737328176176 -0.00130696162098594 6 -1.25061186777426 -1.33758928717182e-07 0.483751242671581 6 -1.14473297641949 0.432837122826554 0.551311275102296 6 -1.08549011586082 0.714475068014843 0.717154191225606 6 -0.999907478503169 0.999999320281388 0.998650025627777 6 -1.02304056831319 0.701274229804443 0.341461518614225 6 -1.00009211269022 1.00000018897268 -0.00134995845333572 6 -1.04990784125832 -7.02601034145168e-07 0.998658341489169 6 -1.0000924988611 2.28328456377122e-07 -0.00135086111286168 6 -0.814083828695644 0.447176153388166 0.998615247647071 6 -0.852640825131751 0.999999653507302 0.548554721997283 6 -0.78599739337886 0.54421557269862 -0.00138986188776658 6 -0.76273242177593 -3.2574925865257e-07 0.487452738909837 6 -0.714878239814584 0.621969498507796 0.617707650764805 6 -0.544907546478875 0.999999137445581 0.998566094487921 6 -0.500092067596944 1.00000001174861 -0.00144218932856735 6 -0.499907926610307 -8.96985976135187e-07 0.998556885054243 6 -0.500092446241677 2.92216983775338e-08 -0.00144309887012908 6 -0.351004788415315 0.72837216382365 0.282486188171189 6 -0.334243882647298 0.74261064166761 0.687241939316993 6 -0.266127207472618 0.385739873336281 0.445494821651404 6 --9.2429157333956e-05 0.999998926995617 0.99846556785669 6 --9.2237034122762e-05 0.499998924494043 0.998465115915096 6 --1.80438362474238e-07 0.999999378532711 0.498465574055852 6 -9.20668819022411e-05 0.999999829897268 -0.00153441543607879 6 --9.20548162607488e-05 -1.07947976955212e-06 0.998464656027355 6 -9.22528411916267e-05 0.499999832584377 -0.00153486796743203 6 -1.9466971532285e-07 -6.21033003508999e-07 0.498464663501957 6 -9.24447448334037e-05 -1.63367929941838e-07 -0.00153532580355122 6 -5.26486499773136 0.192528563745984 0.141177606198921 0 -4.2840852130326 0.78086536543205 0.157291934950649 0 -7.70804416747291 0.144991341730897 0.818178198135377 0 -1.27894645584351 0.189542488712661 0.169713462455346 0 -2.28332347519611 0.174029041214547 0.803384903903656 0 -3.2414615644897 0.166386734147028 0.197789214433918 0 -5.57773347633146 0.548173864203841 0.823741288788814 0 -6.22905991377936 0.785853406839426 0.217649543898984 0 -4.23549161322939 0.151935807513197 0.79542653227732 0 -7.20458594306677 0.156195864761853 0.170246373242037 0 -9.4463009701395 0.338100513885033 0.79607699045034 0 -8.73693861047176 0.126784515019748 0.879004405691388 0 -9.36601720625748 0.742101807302649 0.999982621127108 7 -4.27034233799432 0.17356618612849 0.188584083030817 0 -1.23845100829642 0.810317520551751 0.161406680940784 0 -0.994841345596765 0.175509988023879 0.664335768608618 0 -5.22969977633496 0.808924004755984 0.151154833037905 0 -1.73676274679117 0.209782806371916 0.153493567107228 0 -5.77873403007283 0.231083883043914 0.227369894295652 0 -8.24986039495404 0.128759528208614 0.834285486955762 0 -2.7333976429017 0.169636410959575 0.80666353266194 0 -7.7689704249176 0.834266477759513 0.165678149770203 0 -3.77309900058083 0.183623151325756 0.190113774709306 0 -1.72130092787557 0.759653243709612 0.201497097012836 0 -5.76366319080327 0.840763651417111 0.134830909355775 0 -2.7749169584927 0.152294993383928 0.190710084679056 0 -6.21088141670303 0.250775748444456 0.213429054503712 0 -6.7760199614319 0.82594149368538 0.167504745661399 0 -4.74692445190613 0.215502287490159 0.204524461357673 0 -9.75508658349018 0.667739023896284 0.999994273651269 7 -0.780218811655726 0.206663657654733 0.181992181606295 0 -9.28101879133262 0.824368444302036 0.145757580409677 0 -0.745211890773024 0.187001331914068 0.803730522275016 0 -4.51164900783621 0.424651957336747 0.603283748507138 0 -0.726873509504877 0.775046461530293 0.24774548552512 0 -9.270793194377 0.176792010214677 0.850351331940696 0 -6.20267655454269 0.781303793364693 0.783870062397215 0 -0.729022050650628 0.833889057185503 0.808974082392537 0 -1.63863956761943 0.4927302894113 0.819679465750912 0 -8.98117609175801 0.285805864523792 0.403754804753514 0 -9.87500388622475 0.875000911842376 0.124997368933781 0 -7.8253749058012 0.169531762174916 0.434918892359647 0 -9.81169098344633 0.806702138749347 0.838920253054424 0 -9.84667541498543 0.185439471815056 0.856377057333468 0 -3.78492151407022 0.777523227701078 0.163103990449408 0 -8.96872343799302 0.999999445027543 0.628402780989656 7 -8.87506650443996 0.729981358626134 0.999952766657622 7 -8.73770221105562 2.27796090027203e-06 0.755439834100288 7 -8.84894434562767 0.631152038585108 -4.95186612096809e-05 7 -9.72299181495756 0.999997798683937 0.999994101224084 7 -10 0.724999999999999 1.00000001283563 7 -10 0.250000000000001 0.999999987266238 7 -9.64179820077308 0.24388131620879 0.999991261963319 7 -9.74999355500132 1.23426747237194e-06 0.999994448072144 7 -9.54307816061163 0.465275334900332 -1.16602168213934e-05 7 -9.64532995679087 0.219996156545236 -7.27548557402646e-06 7 -9.76488041636972 -9.69424343119976e-07 0.314001552922608 7 -9.7178320726887 4.46802768002743e-07 0.571521950022207 7 -9.99999999999999 0.479172392535327 0.483632882017373 7 -10 0.313905216484419 0.244399808373131 7 -9.53841534674212 0.999999875586062 0.556396398947864 7 -9.65030298310292 1.0000016860411 0.272751470105242 7 -9.65355325216561 0.73450632067779 -7.51248477694243e-06 7 -9.69972087308095 0.999998607851283 0.727160236209833 7 -9.53327707408699 0.525087789347177 0.999988127156794 7 -10 0.617155360286911 0.744603715041413 7 -10 0.748356956223471 0.336114453459895 7 -10 0.250000000000002 1.74579613617006e-08 7 -9.75000704301428 -1.83487642529919e-06 -4.10951355395346e-06 7 -10 -1.66877357392374e-07 0.250000000000223 7 -9.72000871814533 1.0000023012743 -5.0255935044399e-06 7 -10 0.749999999999998 -1.74579613617006e-08 7 -10 1.00000022335418 0.275000000000375 7 -10 0.999999778678986 0.72499999999963 7 -10 1.68212376251554e-07 0.724999999999788 7 -6.28517816001407 0.353777697371555 0.584894438753216 0 -9.41197824413078 0.532376758271734 0.224593718930043 0 -9.7892057899044 0.137370042864407 0.701181105984401 0 -9.31879085864576 0.338005185117059 0.189888596173345 0 -2.84149992452449 0.616264935251726 0.998990669597961 7 -9.82291626066883 0.125000126249877 0.372226034235199 0 -9.19894925665456 1.4273858905774e-06 0.60999882002818 7 -9.09690238029959 0.337154481097328 0.555821323651619 0 -10 0.310923244734143 0.708391156890862 7 -9.82344175315669 0.218577940096976 0.150665258244016 0 -7.74373750287642 0.748948720157071 0.999834714199209 7 -8.65905092511889 0.24591007525455 0.225414371874738 0 -9.10641621491434 2.46183952617851e-06 0.796255821941023 7 -7.84673782709487 0.179512859448659 0.722558516366745 0 -8.81459614943806 0.297623007553574 0.343873968146127 0 -2.5874154004723 0.290012985454957 0.303635129674692 0 -2.24488132551565 0.786217830643316 0.82582228137583 0 -2.00689122091128 0.734059406839936 0.280209669963393 0 -2.93370079032882 0.77157067014494 0.772604361336196 0 -0.383109826857147 0.19286995127899 0.222025861390637 0 -0.425362186358639 0.538063699470774 -0.00145639397665768 7 -2.87658163013205 0.393503881666659 0.701463385808777 0 -2.1972273941143 0.282335049831062 0.548519874806133 0 -2.64003339172003 1.00000023316548 0.66539752804065 7 -9.15748172715031 0.192234459670925 0.309463617676798 0 -2.50395062562389 0.659311537892743 0.99892800334078 7 -0.21931117581449 0.245581268781437 -0.00149466549049322 7 -2.13275245442177 0.691964354353687 -0.00114083753864151 7 -3.39852240131517 0.684822151022399 0.793885989245554 0 -2.97067603032396 0.539937268324907 0.232957490374312 0 -2.07334938636639 0.99999999197867 0.693224625299046 7 -1.8509621274681 -1.02671221652715e-07 0.682354392611105 7 -0.343154804467895 -4.13446706725928e-07 0.412171559981549 7 -3.389387587147 0.345554518028162 0.76969371136787 0 -3.06544642205644 1.00000081395059 0.222084733841966 7 -1.96784338803535 0.19654161497554 0.296778544667314 0 -1.84278561113783 0.271830634808158 0.608978680971967 0 -3.09001382443187 0.295378195585304 0.999036597710001 7 -4.15509284454665 0.546349276935309 0.791688447370994 0 -3.41414515387608 0.718817681884641 -0.000902742885346765 7 -3.25759248584541 1.00000113703344 -0.000931597247141039 0 -3.05707766986457 0.703701001538224 -0.000969184849319631 7 -3.12629404148796 4.24865845255364e-07 0.684775560293894 7 -2.73901566588618 0.736645136374844 -0.00102828358723191 7 -0.712050825869051 0.432554606560609 0.324614363349321 0 -8.91218900085049 0.79041788353051 0.172737372931275 0 -5.05831351486389 0.290172095186673 0.718045070296177 0 -5.37502419452667 0.686340676958265 0.360731634725307 0 -5.99110924967574 0.291885832009925 0.820017216123218 0 -5.5270755987791 0.31381867474871 0.999484415418289 7 -4.88652175627079 1.28283068578135e-06 0.677357835115733 7 -5.14310980199636 0.375408435751937 0.255412523587214 0 -7.89679013853522 0.223276486779445 0.999854005082716 7 -5.73098186570378 0.785475241666395 0.845397150146045 0 -5.3456154367833 1.6385512114226e-06 0.66506794470866 7 -5.85056349941382 0.670569526438622 0.500045160138518 0 -5.83929425845844 1.00000126919537 0.734061920941509 7 -5.68705204202196 1.96948009541915e-06 0.724771826294604 7 -5.90800608773322 0.740763003073192 0.99955163841085 7 -6.1347388649125 0.234894408979252 0.515394404709551 0 -5.07251566147097 0.702347973245602 0.660724142478694 0 -4.77624584000012 0.170148880429101 0.853076282399514 0 -2.02078195573502 0.308108506762281 0.798996053393529 0 -1.23826870790421 0.197356955036773 0.788035213010711 0 -1.37502555829994 0.686339018998037 0.359992468173977 0 -1.09598474394034 0.356009045656932 0.246217878781783 0 -1.56963214471124 -1.88044860208703e-07 0.65796677815748 7 -1.2646416599943 0.799627046739491 0.868513806089988 0 -8.38962457816492 0.517236522617218 0.999908664570275 7 -9.28602273508154 0.24405330911265 0.473109231928626 0 -1.19386144365816 0.999999617372083 0.740147262862624 7 -1.16757361301335 0.715946718454417 0.998680721348019 7 -4.11765132005356 0.304692901613698 0.366714630376087 0 -3.68212310185242 0.808132674758289 0.819015855415091 0 -4.39697504294817 0.720584841382782 0.749504351459163 0 -9.26311276616786 0.818446532989304 0.872995777854278 0 -4.31718335005832 0.366263766737381 0.662187681134628 0 -4.30239867082308 0.575302716160586 0.29978633553876 0 -4.15199628219453 0.71374030063063 0.999234341495196 7 -8.80657000402522 0.889595362286879 0.785814469348309 0 -4.14835773753437 1.00000077067618 0.683629994075124 7 -4.48200102083503 1.00000101654024 0.608988099154079 7 -7.99898526912478 1.00000275318402 0.356411931659082 7 -8.12501554708251 0.813663219215784 0.361156223261004 0 -8.00735358835509 0.521243767243763 0.670974894925299 0 -7.8746952379637 0.404429232834548 0.321678133499106 0 -7.78854404407629 0.662940011018219 0.583582653512443 0 -7.76879925280215 0.746128034950524 0.353515081411183 0 -8.4109537540772 0.797572770737975 0.78501622775471 0 -7.90614567818117 0.838502091351008 0.514772303526234 0 -8.77312789064265 0.81315734104314 -5.48760226446734e-05 7 -7.50940431302969 0.873065245986758 0.393406179475738 0 -8.63904149144467 0.999999794736911 0.662270227850229 7 -7.65737155798146 0.814689511052364 0.741008190967565 0 -8.28597919218168 0.297574572737789 0.501767808650535 0 -8.92377892944551 0.999997889114799 0.822636080684725 7 -9.10065528496136 0.920489682359863 0.540781223397844 0 -0.664750061698971 0.301623504981497 0.559006743965374 0 -3.76836556062475 0.132175569027311 0.735877887434276 0 -0.845965106665334 0.757176322694367 0.998621407609801 7 -8.28792871744129 0.227688655944154 0.255378423725753 0 -8.5861201296218 0.574013795967417 0.306501099065218 0 -1.31719442978389 0.487272216983241 0.865122355768729 0 -2.67438018301194 0.821653320674812 0.858619407192004 0 -9.06981048763853 0.168737974507576 0.836945276378935 0 -4.75532602513052 0.272808836512847 0.584611521374503 0 -4.54732290255763 1.17545215959412e-06 0.653113279315891 7 -4.43348900535885 0.124767985689123 0.616695389306094 0 -4.85790609021697 0.725582169722756 -0.000635652258497858 7 -3.01749975573854 1.00000048626589 0.552696168645086 7 -6.79295137074243 0.317458246729665 0.500906530345512 0 -6.77473527115899 0.168400336271201 0.819152029059543 0 -6.71153999145821 2.49429694549184e-06 0.658661364563359 7 -6.765544152373 0.641658970335441 0.606952748200415 0 -8.86114826672139 0.429273734744517 0.739259934732857 0 -6.30852093861852 2.37685401762829e-06 0.733132967089864 7 -7.15058061306164 0.691487064617975 0.513817947299214 0 -7.10325055586392 1.00000131575844 0.733546268930952 7 -6.81323737717057 1.00000129716449 0.731965157236988 7 -6.97991333083726 0.756664025434923 0.999727147921848 7 -7.4357901470984 1.00000119008247 0.734080466379152 7 -10 0.221596543102558 0.471580040966596 7 -3.20049932707158 0.866771360231477 0.805951809000422 0 -7.24693010361339 1.00000029853032 0.999767487868149 0 -8.18909682304185 3.31716706988903e-07 0.211216226759477 7 -9.34008062988705 -1.7317626506478e-06 0.17796433697551 7 -8.50002774079849 0.14450919329897 0.186259917365091 0 -5.75747174877648 0.248053065083069 0.783107342209906 0 -7.73494978831904 0.574235812664406 0.195233061448647 0 -8.09322327071507 1.00000043290674 0.666498807218896 7 -9.62287342989983 0.742521904570981 0.708295829969852 0 -8.92195640725964 1.00000295670829 0.194627196603212 7 -3.74771310161155 1.00000056571028 0.743858427137174 7 -4.94754167653424 0.387281251923813 0.99938032844201 7 -7.05012321532308 1.00000326217999 0.268408374213214 7 -3.52026026691034 0.817415070954834 0.591977897867022 0 -7.07444850863704 0.700950838055566 -0.000258884268446202 7 -9.62577853591188 0.568860923842544 0.179056289839408 0 -7.25617905990584 1.00000456785709 -0.000231049482347997 0 -8.3709835363262 0.507376280620607 0.189455350746666 0 -8.087087838405 0.21233150316935 0.399914474342727 0 -8.1669659670341 0.455584343702868 0.354055013186892 0 -8.06614680111206 0.319222839844471 0.866814550843532 0 -7.68008712162227 1.0000009843417 0.718226703924912 7 -8.84257008089607 0.352494298188196 0.132759678219132 0 -8.06282592800991 0.477266718787621 0.152218470145664 0 -4.7069964017969 0.813299719439489 0.770826051228715 0 -1.5028848803531 0.600895333221875 0.998742553236795 7 -7.82130269764331 0.715953833440969 -0.000155363527219035 7 -5.26513894478245 1.0000010538072 0.714925479188342 7 -9.56071370649789 0.352534611315959 0.105293699338206 0 -7.61158874159903 1.29660814202697e-06 0.236289669066936 7 -8.41086090088594 0.134400144515646 0.433256004874831 0 -7.64521655543852 0.293639532405873 0.520232906696157 0 -8.62500725566447 0.144509975550277 0.403036287966308 0 -7.62681090331952 0.209598150515811 -0.000180688187740717 7 -7.54444378418497 0.130319513803301 0.397233335967396 0 -9.49467452366895 0.395337416256429 0.395352083743365 0 -8.37503937515151 0.289019455382119 0.0930765958973437 0 -7.24994724264601 0.129483316842118 0.86618070967531 0 -9.68719110577965 0.62939387257008 0.498997949443532 0 -9.51113703914302 0.381841483545048 0.592170952050725 0 -8.55589268606242 0.746639522894669 0.999925751042638 7 -9.16015132009147 0.600036292561878 0.860172742713639 0 -8.22120686654832 1.34159700050885e-06 0.437546791422137 7 -1.70910078288856 0.99999987587724 0.67154402390841 7 -6.94570368464074 0.34628367009078 0.811631690665301 0 -5.93922515621939 0.42082684363507 0.258659823907004 0 -6.13477456401355 0.484894811105165 0.298629992591249 0 -9.03456637942745 3.51500570443006e-07 0.434531513992589 7 -6.52605979723473 0.686489987435806 0.304263241559147 0 -2.11588044839066 0.688957551273978 0.998856055548275 7 -7.25003266168143 0.472051540386798 0.267109208079227 0 -2.47172524931664 0.633204954280823 -0.00107802133294998 7 -7.78006066780505 1.15372285061702e-07 -0.000160644156862601 0 -3.17917727703251 0.670444263141376 0.999053530166263 7 -7.46361025106188 0.690789244052006 -0.000202633795875521 7 -9.29604165995822 0.307250191238319 0.663506581892454 0 -7.29778641288409 0.721663558513361 0.242030722160571 0 -1.7453485021271 0.635246582347708 0.523738867266747 0 -1.74628648639486 0.732001548680727 0.998787673268544 7 -9.07285827702012 0.67151890604073 0.289282272771077 0 -3.37295357490271 1.00000052138705 0.679474117942851 7 -8.80107098629892 0.613660961857687 0.311906282006093 0 -9.7982743700763 0.795150712901373 0.605523536307598 0 -6.01936998646027 1.93907044126056e-06 0.595167362217971 7 -9.49625675945026 0.153807710530659 0.473162906826869 0 -8.28058385740242 3.75276223112434e-06 0.999898317664924 0 -7.88871368516905 0.595345974734495 0.827552740411769 0 -1.01508608991616 0.40719741952268 0.808401315137323 0 -3.4588493802709 0.677879695868771 0.999105579419763 7 -8.87106795192452 0.243168308311815 0.602345666666452 0 -9.03877892775352 0.640573114845943 0.682407308564162 0 -4.79632154270949 0.654392141334435 0.999353085050184 7 -7.89405842204424 0.800420714727798 0.886629798918531 0 -8.5262858083173 0.541851874920838 0.803894701886229 0 -9.01994328491733 0.370244370641075 0.840953225103777 0 -0.417458870350062 0.448006586925409 0.76908434906649 0 -9.61336810363712 0.626627387683548 0.868515458801462 0 -8.96838284215858 0.832969430576531 0.629870856641457 0 -3.15836969217098 0.791424491515796 0.574027618387165 0 -8.88419210306186 0.915784937793 0.907431041159982 0 -8.78003734385116 -1.92492254487307e-06 -5.44110519581789e-05 0 -5.62780996335424 0.646334530625944 0.262972880719857 0 -0.454196164444546 0.999999566367277 0.478185780190427 7 -0.222084757522061 0.772130466627381 -0.00149367450202815 7 -0.227766245777783 0.999999697117366 0.238144368287713 7 -3.38262804169821e-05 0.659309663050621 0.314831936290386 7 --3.53601082008934e-05 0.731926682289653 0.689700261583203 7 -0.263282873371108 0.999999262642199 0.737864010399822 7 -0.371340984403742 0.682387466063854 0.998533792185501 7 -6.77121365110731 0.398474273163338 0.211332028655731 0 -3.98841779834497e-05 0.296670262888298 0.282733914791302 7 -9.84015743252336 0.524493586544482 0.5244915591558 0 --2.71750641170024e-05 0.349331603286314 0.646110745505106 7 -8.18604279025027 0.228073110270252 0.717186966821172 0 -4.86883123795589 1.00000105029406 0.687873261682077 7 -7.98945662222698 0.745733791169185 0.0979374604000964 0 -9.40440269306672 0.619804271096378 0.703523466498339 0 -9.28994269139307 0.681960145420805 0.306964872176174 0 -6.13473882692795 0.734894653055173 0.515394794587859 0 -6.98006658127844 1.00000206079446 0.520442612317978 7 -9.75670142350169 0.862190880902827 0.406595488984097 0 -6.98979710093829 0.474875418396153 -0.000272045854249184 7 -8.70236407747468 0.629921150404943 0.495949793584328 0 -2.44779563496366 0.445936228837009 0.810081558472698 0 -0.317255686981748 0.192453981771854 0.728762156557726 0 -9.48894460041999 0.790492669233654 0.497931580908643 0 -9.76311160138351 0.38242294808575 0.862386494197293 0 -8.53834976474709 0.912903072261887 0.0722177525573084 0 -9.10752334240853 0.21309676653703 0.999969136369301 7 -9.19623637200065 0.438106394314941 0.313457820283165 0 -7.7499374144466 3.93806129936787e-06 0.999835913718144 0 -3.23380581180297 0.230663582543953 0.542409759037026 0 -9.81533259096736 0.587126511291021 -4.17036896639862e-06 7 -7.59505015716576 0.2552594668452 0.999814856997382 7 -8.32519776091002 0.999999592428523 0.770047798950738 7 -8.87320543691975 0.222413930623581 0.999952428698715 7 -7.91971660427158 0.22731907619946 -0.000143869356485006 7 -9.49731593144987 0.694863931621626 0.153479302172062 0 -8.20630570021138 0.862013498031929 0.811940215330047 0 -8.234426098793 0.287784220536022 -0.000108131589628858 7 -8.42617760186245 4.02092525023699e-07 0.310574596132025 7 -8.2366661642854 0.652575567763163 0.302380291585512 0 -8.35983910496434 0.23906082181166 0.99990569793862 7 -9.0620800587965 0.80923599996126 0.137640075356918 0 -7.73487589706666 1.00000360601563 0.221906607635452 7 -9.38501643944077 0.707952493823164 -1.64230773602469e-05 7 -8.71383548614103 1.0000044452471 -5.91181707268016e-05 0 -8.67233700841568 1.00000297530416 0.202751697477957 7 -9.08964723336621 0.621760934393897 -3.25962982620682e-05 7 -9.12258263874521 1.00000138120025 0.384461861393442 7 -9.1757849418125 0.218130894735581 -2.72761145391565e-05 7 -1.82756695785424 0.483610853960103 0.311782182642119 0 -9.30285236977883 2.19899870567551e-06 0.800852203006741 7 -9.15014770225564 0.999998086675672 0.784421030028036 7 -9.60503472152646 1.37330202809935e-06 0.793547516711651 7 -9.14341386457168 1.0000030855624 0.167805694615255 7 -8.28947030270384 0.77792334297996 0.544406911477625 0 -9.20527280692201 0.672101186924681 0.504382155414968 0 -8.79381378927614 0.775563845272643 0.878469251694894 0 -7.11055578884551 2.73387821621838e-06 0.746390901281594 7 -9.82533594854178 0.419399779551313 0.300181743596504 0 -4.80594379162245 0.468208544529015 0.312567303503858 0 -8.52921730033068 1.00000206922187 0.36710175672981 7 -7.85777297534974 1.0000013013723 0.588740011425605 7 -8.49086796688754 1.79870773334783e-06 0.634490822415402 7 -8.79305756847184 0.872725205738989 0.576217419379907 0 -8.70235324852545 0.488303098847958 0.637566644361936 0 -8.10694249893923 0.115929318951789 0.844508450943435 0 -9.36570098945988 0.14888655063403 0.129075949832124 0 -4.57549667867056 0.5670782102371 0.828171060881092 0 -8.0661142234826 0.674834902092425 0.999873972199899 7 -8.71591084046246 0.999997068389426 0.999941183829098 0 -8.99580871933813 0.442081430874203 -3.90752339711846e-05 7 -9.46840097948371 0.819654870556629 0.828435480076646 0 -9.25775089395754 0.843447438326536 0.434621335594971 0 -9.03045900539049 0.284131540185769 0.146299379947337 0 -9.17985406250343 0.487103916373308 0.681561226931696 0 -6.42760156527773 0.608724037433914 0.771841672319035 0 -4.4328880799389 0.585250094548992 0.999286172298828 7 -8.33045924523228 0.550811591535667 0.825660761523448 0 -7.70407929631279 0.231421170694141 0.242034828838541 0 -8.53596790798957 0.655956489488938 0.643409444617637 0 -0.993260146729796 0.854587964808565 0.640382754484102 0 -9.17751598235428 0.394352845713643 0.999972891751746 7 -8.81146229797685 3.62881182772549e-06 0.99994822323476 0 -8.56605573099974 0.74014458321234 -7.32529849773161e-05 7 -9.4308485998419 0.844555307161181 0.291187702618601 0 -9.82613930952896 0.254431711788733 0.523662683756325 0 -8.94627182830772 0.456525924366079 0.29258437240845 0 -9.37612950916229 1.00000261768337 0.203919438472789 7 -9.84359555288982 0.68969693628504 0.374498974721766 0 -7.88575090438521 8.87317232087158e-07 0.235188040513101 7 -9.49811264403542 0.560540765996987 0.495359499309331 0 -9.85568035435854 0.574680478942819 0.809562939857782 0 -9.38642875620635 0.151393520920028 0.650301010954728 0 -9.45290768139978 9.32928845682915e-07 0.592682680970831 7 -2.26519102805796 0.752055874736078 0.142198183397108 0 -2.38624714736845 1.00000011720808 0.686470782321037 7 -9.57933641294964 0.182604203515161 0.246188012860999 0 -8.08188911434077 0.684623445863738 0.515745772824727 0 -9.22743274025705 0.749879909295441 0.668061003159684 0 -9.24984697950296 0.999996247307221 0.999977512987529 0 -8.93328919432574 0.815321748095006 -4.25878248427904e-05 7 -0.954649746991724 0.19853799498485 0.390792847133444 0 -8.91128275524188 0.905254360382663 0.505303947381341 0 -8.15699805619907 0.182129685358132 0.99988439700095 7 -7.04882554540049 1.93126465673615e-06 0.412964080053589 7 -7.78912829912335 0.405707744269751 0.740161837725245 0 -3.7899973930481 0.358660055689405 0.377339215539132 0 -8.60262463523915 0.891014248838967 0.504516905318234 0 -7.87005477278207 0.999999704919101 0.82149566470208 7 -8.41988829309756 0.354963053496455 0.823048853053077 0 -7.98508116858499 0.460850288920664 -0.000136258948944457 7 -7.94487560854142 0.444366373775054 0.487759486456604 0 -8.51856470123458 0.37736890490589 0.620679564091989 0 -8.91847527517329 0.213809753586497 -4.42827235791214e-05 7 -8.44466408957944 0.500082862804113 -8.61414466670591e-05 7 -7.90812485958509 0.146064141421002 0.238600853425698 0 -7.30233692398753 0.236026929432401 0.412880806424854 0 -6.47633505015214 0.801927734492951 0.623788472848005 0 -6.70188920421529 0.795141284562481 0.812189060400094 0 -7.38241394063585 0.770392554004317 0.999786040064442 7 -8.4963154270174 0.268092928294286 -8.0632674382015e-05 7 -7.50100466235968 0.108803160887042 0.798469553322339 0 -5.27972862056849 0.836721749232388 0.840060623740744 0 -9.83766879106317 0.634986776243097 0.156550233967534 0 -9.79139722863876 1.00000013064119 0.496773696674327 7 -8.65454663442488 -4.04023006814147e-07 0.250951246588696 7 -7.30549982695113 0.3219193650055 0.77380517147642 0 -7.85524960381087 3.05612087286769e-06 0.755984614762679 7 -8.38982395382764 0.818689413629604 0.179900578125841 0 -2.17452113670182 0.539059700690398 0.314628637245942 0 -5.69236787001376 0.37192850270947 0.515447815440894 0 -9.02878352130485 0.920490929936132 0.394028515673428 0 -4.94679218349723 0.443294732478865 0.136178289990952 0 -9.79192909783896 0.414547133541167 -4.60650848108806e-06 7 -8.85390232223102 0.185389074337643 0.783812515741294 0 -9.50379747249561 0.848973906974583 0.143648173994203 0 -9.57720178232238 0.463427721911132 0.796081210347138 0 -8.88176562882534 0.799517792098158 0.379198126227293 0 -8.60199483232528 0.693530936681497 0.822233674344916 0 -9.21469787414148 0.611326192213784 0.1455955991526 0 -7.34028635418774 1.52764390440406e-06 0.274936020833898 7 -8.68437990946282 0.375643688762773 0.431353073808887 0 -9.24752405299399 1.00000417911779 -2.20006775617796e-05 0 -10 0.538926031607589 0.229208007043657 7 -8.98299532038967 0.555047685494912 0.834490144754017 0 -8.59767740015694 0.849537886412297 0.84458833768769 0 -9.42713024841033 0.999997954916129 0.791155874406124 7 -8.06664764788744 0.238555396107556 0.156036170307605 0 -4.14812591775923 0.758078031046586 0.583652957016226 0 -8.64296435067609 0.311361291683877 0.821675391985368 0 -8.56456147294451 0.764409498478421 0.42185173936385 0 -7.22488746678147 0.289055031537641 0.999763036919296 7 -8.75621476828597 0.567511281357641 0.8563359590158 0 -8.8860735272189 0.648584634163124 0.588553774612671 0 -3.48691717150103 5.83514143747091e-07 0.686053710722181 7 -9.19609663326626 0.88032658172883 0.281505955582587 0 -7.44577862815985 1.00000339878834 0.237643172182748 7 -6.22547036014532 0.189642068057806 0.817694024641174 0 -9.44461722396549 0.856232491264067 0.680415905490061 0 -9.05738931778176 0.137199476085002 0.493927364400001 0 -5.58063573916505 1.00000132468248 0.651472324013151 7 -4.94786496207159 0.201505340723343 0.366010769512852 0 -9.01677569559103 0.550650432138692 0.491971667078064 0 -9.1132982350228 0.828634796270486 0.999969539925229 7 -0.179535187189707 0.727785290581673 0.47664232552534 0 -1.54890231293965 0.609932597678871 0.178643776049841 0 -3.67394037568532 0.299224395218035 0.663828549885454 0 -9.52268192888361 0.225916169015649 0.791982788313592 0 -8.20801175191944 1.0000034750053 0.229407181487638 7 -8.95026012615038 0.454211500093425 0.999957804625558 7 -7.31313916452929 0.454836335378218 0.529633104638397 0 -7.85004851588035 0.348419091369922 0.132094641909228 0 -3.69133191055121 0.591094398179341 0.305242087539391 0 -8.03665378570841 0.116545443706089 0.642711990825692 0 -6.88383647698066 0.257813221783214 -0.00028817032191392 7 -7.54092762411282 0.55453608978485 0.761761310005829 0 -8.65990092513151 0.801864632063364 0.302418497146849 0 -7.02276203600504 0.313663328647114 0.316042077254528 0 -8.90207625852855 0.580832808156291 0.151319326380497 0 -5.82826011297921 0.49233518825983 0.757325238270572 0 -7.5194888057542 0.500233877154656 0.188850954673143 0 -9.439697695705 0.50798959994079 0.89259865628739 0 -8.41098156860241 0.442083733584324 0.471354996547231 0 -8.20976059350771 0.886337981467424 0.087885828196032 0 -9.58638190088093 0.791729448257187 0.999990152124809 7 -9.41648897636676 0.262684528183863 -1.48650509547235e-05 7 -3.5640297522249 0.368582959272701 0.165802869377838 0 -8.38847859118096 0.215457724843449 0.646182915906815 0 -9.36744467513989 0.277624486185002 0.999982437979778 7 -9.36588376419572 0.144935990084902 0.310234764386328 0 -8.66070610814314 0.491820426897507 0.171986472523318 0 -9.14629776076571 0.201694022288787 0.683979480906646 0 -9.77951237137698 0.462505821724298 0.999994722302969 7 -5.22402360883087 0.280393297935973 0.999430236508316 7 -9.13657322390879 0.814681363505062 -2.90981744142152e-05 7 -8.27598612062036 0.779634379481265 0.999897737354453 7 -8.38076847394517 0.852366342372303 0.357650210807274 0 -8.60607006292714 0.111496028801628 0.820543314519296 0 -7.48129379178263 0.517423590967991 0.999799241175141 7 -9.13460956054077 0.619673256497213 0.999970402071552 7 -9.50739631395168 -4.65549471019479e-07 0.376975354831924 7 -8.47402381805307 0.145357493948423 0.846106327464585 0 -8.98077064475805 1.59451187721272e-06 0.642681276927536 7 -8.43900570996098 0.674316993687894 0.315666257806103 0 -9.2829894213537 0.882721580037569 0.753645291451206 0 -9.53634261794031 0.350339618826046 0.904958334275567 0 -8.30821921870698 0.424193082136728 0.663714285086991 0 -9.41055793959839 1.00000115732684 0.392960733329171 7 -9.27716491137724 0.421350538565504 0.840971188854085 0 -8.93120427342226 -1.04211781041804e-06 0.216943925380077 7 -9.72788688906726 0.297547511885332 0.702040887124894 0 -10 0.749077265301376 0.558318782842958 7 -2.68694740231961 0.602408608921565 0.772558352426516 0 -8.67886494198052 0.185704771502095 -6.34508483890227e-05 7 -8.14624862941348 0.655967315597263 0.731116606932833 0 -7.97907588423365 1.76809286510639e-06 0.463665274724978 7 -9.57296000116773 -1.95915274755727e-06 0.178022330042829 7 -8.60342856201068 0.249594201257352 0.99992939093456 7 -9.45346732508808 0.119177464138322 0.900153250549835 0 -4.59047201322056 0.707503250306099 -0.000684666077581117 7 -8.95157002142188 2.75972220759458e-06 0.84120512478329 7 -9.1631753156982 -1.11177675539428e-06 0.215393003857938 7 -7.1682649104059 0.874565860921038 0.87421787930823 0 -9.29835900865903 2.925547676014e-06 0.999979528682916 0 -8.53291078447407 0.999998649403254 0.854604753324144 7 -6.59547785334497 0.304745792614962 -0.000333512274725375 7 -9.04979198478541 0.815426599723618 0.808193428911829 0 -8.90868547251102 0.144890761705881 0.240394010726168 0 -9.08279277669939 0.479705231397218 0.153873894167834 0 -0.369995452724308 0.328688123732551 0.998533222314261 7 -8.90130029194283 0.0874687488781205 0.076053678173299 0 -9.62578869936403 0.20837526118263 0.585202693627809 0 -8.09269136019049 0.831067355030435 0.181465537421607 0 -9.6630785978667 0.156494059327979 0.844434062996958 0 -3.73121391335542 0.273586919253515 0.999155856073638 7 -8.64207468104403 0.196535462859363 0.65083621268778 0 - - -Corners -8 -1 -10 -11 -24 -217 -220 -221 -224 - - -RequiredVertices -8 -1 -10 -11 -24 -217 -220 -221 -224 - - -Tetrahedra -3028 -226 134 135 129 7 -482 422 435 143 7 -193 190 196 228 7 -229 180 322 176 7 -668 215 219 508 7 -162 173 168 167 7 -173 168 167 177 7 -168 167 177 169 7 -57 234 644 620 7 -542 426 452 454 7 -368 23 495 462 7 -581 710 442 718 7 -708 602 575 375 7 -599 167 166 316 7 -475 318 304 155 7 -157 329 161 151 7 -80 85 77 300 7 -216 214 319 222 7 -704 281 600 486 7 -207 213 319 320 7 -63 453 456 620 7 -317 598 327 179 7 -183 179 317 248 7 -162 173 167 323 7 -249 88 503 95 7 -527 522 286 285 7 -156 147 341 334 7 -224 213 326 319 7 -168 156 161 329 7 -151 140 328 333 7 -57 620 644 456 7 -681 608 620 65 7 -213 255 319 208 7 -248 179 317 185 7 -169 245 171 165 7 -164 160 152 157 7 -213 208 319 332 7 -599 316 166 330 7 -720 704 281 600 7 -161 157 151 321 7 -643 545 698 550 7 -224 319 332 213 7 -177 182 471 316 7 -341 147 339 340 7 -89 261 358 82 7 -151 156 334 147 7 -512 216 332 319 7 -98 347 108 360 7 -158 343 162 170 7 -224 319 222 512 7 -167 156 161 168 7 -158 156 162 343 7 -726 423 623 420 7 -157 153 165 160 7 -356 98 97 664 7 -330 316 166 178 7 -156 334 341 158 7 -165 157 160 250 7 -157 230 160 152 7 -152 164 329 341 7 -33 581 495 388 7 -154 337 163 159 7 -341 343 156 158 7 -163 154 159 245 7 -156 162 343 168 7 -54 609 679 535 7 -501 395 573 12 7 -350 107 346 354 7 -341 329 156 343 7 -147 145 149 138 7 -229 169 171 176 7 -306 20 596 597 7 -208 197 204 605 7 -49 424 40 541 7 -181 242 186 335 7 -463 7 685 237 7 -44 387 246 428 7 -103 107 96 100 7 -107 96 100 354 7 -255 204 605 208 7 -595 484 267 290 7 -184 362 331 336 7 -100 99 98 108 7 -178 182 480 465 7 -141 372 610 247 7 -570 725 425 693 7 -100 354 108 107 7 -354 108 107 346 7 -351 112 108 347 7 -96 85 359 485 7 -66 472 436 478 7 -347 112 360 104 7 -412 80 77 410 7 -124 120 406 407 7 -241 112 347 104 7 -65 466 59 67 7 -144 142 247 610 7 -412 410 411 561 7 -448 428 51 614 7 -243 100 503 95 7 -472 62 436 476 7 -6 539 287 437 7 -354 357 99 102 7 -82 300 661 348 7 -358 261 86 82 7 -96 103 100 243 7 -103 100 95 106 7 -103 100 225 107 7 -374 381 380 119 7 -574 577 732 444 7 -174 180 362 229 7 -440 400 445 441 7 -197 186 193 190 7 -503 100 347 106 7 -197 189 198 363 7 -190 197 189 198 7 -189 364 198 188 7 -141 372 134 610 7 -200 367 187 371 7 -189 184 366 336 7 -168 315 322 175 7 -231 93 105 349 7 -195 189 184 192 7 -341 334 340 158 7 -201 364 239 194 7 -578 9 666 559 7 -198 190 365 364 7 -189 197 192 363 7 -197 366 189 192 7 -186 193 190 242 7 -193 190 185 196 7 -190 228 365 196 7 -193 190 228 197 7 -339 147 141 145 7 -239 364 191 194 7 -201 365 196 364 7 -412 77 79 411 7 -258 407 405 120 7 -671 735 737 556 7 -708 662 575 602 7 -198 199 201 209 7 -584 370 206 200 7 -392 564 611 37 7 -125 134 127 377 7 -206 584 262 209 7 -114 374 258 571 7 -493 114 116 571 7 -523 472 62 436 7 -66 674 478 416 7 -132 133 140 134 7 -140 132 134 138 7 -69 412 411 561 7 -448 428 476 51 7 -125 122 372 377 7 -132 139 131 373 7 -147 149 340 334 7 -356 520 83 261 7 -57 472 684 62 7 -580 120 128 376 7 -21 491 314 264 7 -611 22 392 567 7 -612 565 393 443 7 -139 378 132 131 7 -71 621 413 622 7 -562 13 305 589 7 -138 132 380 432 7 -127 121 125 377 7 -156 334 158 162 7 -376 407 233 130 7 -134 138 127 135 7 -134 269 135 141 7 -736 672 632 687 7 -621 76 413 579 7 -440 464 400 394 7 -127 134 135 226 7 -730 395 501 12 7 -641 483 524 680 7 -209 489 205 397 7 -438 434 478 660 7 -455 57 61 451 7 -273 345 390 587 7 -27 570 280 689 7 -623 679 310 702 7 -361 405 116 433 7 -402 363 195 489 7 -456 266 451 582 7 -694 444 682 590 7 -334 500 151 149 7 -640 714 671 461 7 -198 363 402 489 7 -652 127 380 381 7 -552 570 27 689 7 -369 693 457 486 7 -108 563 665 405 7 -72 74 608 678 7 -77 411 466 70 7 -37 382 672 383 7 -99 349 102 427 7 -382 47 387 389 7 -223 216 514 526 7 -230 148 144 153 7 -453 54 620 63 7 -403 323 166 155 7 -129 126 117 122 7 -236 701 35 721 7 -136 133 142 398 7 -133 134 652 125 7 -377 134 226 129 7 -73 66 436 252 7 -311 731 734 444 7 -94 104 347 98 7 -373 139 131 143 7 -114 121 115 112 7 -266 719 43 313 7 -121 115 123 127 7 -123 121 226 129 7 -440 385 266 615 7 -523 66 472 436 7 -607 515 544 244 7 -405 122 118 407 7 -122 118 130 126 7 -405 114 116 433 7 -734 31 577 731 7 -114 346 405 108 7 -361 346 433 111 7 -122 253 126 117 7 -130 122 126 238 7 -377 134 129 372 7 -120 116 128 124 7 -184 174 180 362 7 -128 120 124 233 7 -125 134 377 372 7 -124 120 350 406 7 -233 120 124 407 7 -54 453 679 609 7 -431 635 545 659 7 -406 407 118 130 7 -112 115 104 110 7 -621 520 470 76 7 -104 112 110 241 7 -122 405 118 253 7 -408 112 636 106 7 -433 105 697 346 7 -313 266 453 43 7 -110 112 408 106 7 -318 409 323 155 7 -85 74 81 80 7 -85 412 80 77 7 -699 540 38 28 7 -620 234 644 608 7 -421 562 305 589 7 -433 105 346 360 7 -71 83 621 75 7 -505 506 211 220 7 -77 70 82 79 7 -393 58 420 391 7 -67 417 726 58 7 -121 115 408 123 7 -112 114 108 360 7 -114 571 258 120 7 -412 411 79 69 7 -411 70 79 69 7 -618 30 694 624 7 -67 417 64 726 7 -282 281 704 486 7 -85 412 77 415 7 -485 661 348 91 7 -58 417 420 60 7 -418 622 64 75 7 -622 419 75 70 7 -623 58 393 679 7 -484 522 592 460 7 -477 461 369 9 7 -52 719 593 266 7 -58 420 623 393 7 -97 98 231 105 7 -661 415 79 91 7 -382 546 45 246 7 -644 52 451 456 7 -81 251 80 84 7 -80 729 84 73 7 -398 670 142 658 7 -729 81 678 74 7 -530 692 727 260 7 -148 144 247 690 7 -77 70 79 411 7 -290 484 267 298 7 -688 430 575 288 7 -88 84 90 232 7 -233 407 124 130 7 -57 62 61 234 7 -167 599 177 316 7 -414 578 307 666 7 -328 373 435 143 7 -432 373 131 143 7 -129 141 134 135 7 -71 621 622 75 7 -479 182 263 336 7 -69 70 466 411 7 -393 310 612 50 7 -189 190 364 479 7 -238 122 126 129 7 -325 167 166 403 7 -73 252 436 68 7 -622 64 75 419 7 -453 582 53 385 7 -202 194 201 239 7 -173 598 168 633 7 -241 112 110 106 7 -321 154 304 163 7 -199 198 489 209 7 -386 39 389 393 7 -25 431 604 545 7 -113 117 253 636 7 -357 99 102 427 7 -731 725 469 713 7 -250 172 165 315 7 -25 431 548 604 7 -382 47 389 565 7 -54 227 625 52 7 -94 104 98 664 7 -378 380 131 119 7 -173 183 317 330 7 -560 730 379 501 7 -600 13 450 457 7 -465 370 188 187 7 -617 31 552 577 7 -125 122 258 376 7 -190 669 479 553 7 -312 306 695 554 7 -174 525 171 229 7 -686 32 691 394 7 -730 396 8 602 7 -2 595 308 528 7 -63 608 561 620 7 -441 439 400 445 7 -447 480 184 263 7 -298 484 288 628 7 -496 695 307 578 7 -57 472 620 674 7 -30 574 273 682 7 -74 80 412 410 7 -325 403 166 155 7 -725 20 693 324 7 -389 383 429 601 7 -152 148 144 230 7 -148 144 153 142 7 -156 168 343 329 7 -198 363 489 240 7 -432 132 131 373 7 -186 176 181 335 7 -356 261 83 86 7 -89 358 683 82 7 -40 426 542 629 7 -466 65 410 413 7 -328 139 373 143 7 -190 197 365 228 7 -250 157 160 164 7 -77 466 413 70 7 -365 190 196 364 7 -183 194 188 465 7 -413 76 621 470 7 -357 427 102 91 7 -83 94 90 88 7 -712 7 685 463 7 -124 361 111 350 7 -95 88 84 90 7 -505 506 220 507 7 -88 232 90 83 7 -492 463 648 578 7 -400 426 452 542 7 -81 85 80 251 7 -550 732 19 643 7 -121 115 112 408 7 -197 190 189 366 7 -92 243 467 95 7 -316 471 166 178 7 -176 165 169 171 7 -669 248 553 185 7 -23 673 537 653 7 -662 650 8 708 7 -261 579 82 87 7 -106 347 101 241 7 -575 602 518 375 7 -173 183 179 317 7 -623 393 310 679 7 -40 426 717 624 7 -301 539 279 547 7 -92 251 84 467 7 -182 471 178 480 7 -616 739 653 613 7 -351 636 665 563 7 -277 671 737 722 7 -432 132 380 131 7 -136 133 130 142 7 -376 120 128 233 7 -433 114 116 493 7 -330 182 465 479 7 -675 455 619 582 7 -343 168 473 164 7 -558 654 33 707 7 -621 83 470 520 7 -525 174 325 471 7 -427 359 348 485 7 -18 560 642 656 7 -315 157 329 161 7 -323 599 167 166 7 -83 520 621 261 7 -351 665 107 108 7 -351 100 225 106 7 -98 100 108 347 7 -188 465 187 480 7 -146 333 738 658 7 -605 197 365 198 7 -266 385 453 615 7 -583 37 388 392 7 -151 161 321 475 7 -186 190 366 336 7 -139 338 132 378 7 -329 156 147 341 7 -444 577 590 314 7 -338 376 374 580 7 -388 558 718 540 7 -300 85 415 359 7 -173 633 177 317 7 -182 362 177 174 7 -511 681 523 66 7 -100 99 634 98 7 -649 728 388 28 7 -207 204 196 365 7 -518 463 685 237 7 -112 636 106 351 7 -213 255 207 319 7 -354 96 100 357 7 -587 401 439 694 7 -466 413 70 67 7 -66 65 674 416 7 -319 214 320 222 7 -616 645 568 739 7 -182 184 362 174 7 -209 584 201 206 7 -712 477 235 260 7 -665 107 108 346 7 -598 170 327 179 7 -662 288 285 650 7 -482 422 143 155 7 -152 164 157 329 7 -337 475 150 333 7 -139 132 140 373 7 -26 530 727 260 7 -382 387 44 389 7 -603 375 555 650 7 -376 120 233 407 7 -168 329 315 164 7 -356 353 358 97 7 -199 188 194 370 7 -14 627 647 296 7 -292 637 284 14 7 -356 358 261 86 7 -448 246 55 476 7 -490 328 150 475 7 -589 299 17 421 7 -714 302 308 268 7 -133 125 376 372 7 -371 195 489 402 7 -408 115 110 123 7 -66 413 71 470 7 -413 70 67 622 7 -194 206 202 201 7 -202 239 201 196 7 -145 138 269 135 7 -30 311 444 694 7 -201 196 207 202 7 -184 362 180 331 7 -147 269 141 145 7 -433 114 493 360 7 -207 201 202 259 7 -652 380 378 374 7 -315 157 250 164 7 -554 695 596 306 7 -121 381 114 115 7 -732 531 643 481 7 -402 263 195 189 7 -338 125 652 374 7 -698 545 604 550 7 -142 130 137 372 7 -117 113 106 636 7 -47 391 386 393 7 -625 227 56 52 7 -132 380 131 378 7 -485 359 348 661 7 -33 718 581 388 7 -162 156 167 168 7 -480 182 184 263 7 -189 190 198 364 7 -415 359 661 300 7 -603 237 375 3 7 -280 279 450 637 7 -383 382 44 389 7 -484 628 285 288 7 -386 389 47 393 7 -397 344 605 255 7 -257 733 497 526 7 -535 352 532 227 7 -487 705 35 566 7 -515 691 544 244 7 -426 311 624 458 7 -106 503 101 347 7 -206 209 215 214 7 -206 209 214 259 7 -209 215 214 216 7 -668 506 219 504 7 -214 211 207 320 7 -215 214 504 206 7 -190 185 196 669 7 -422 318 475 155 7 -74 410 681 511 7 -320 326 319 222 7 -738 333 670 658 7 -503 100 106 95 7 -249 94 503 88 7 -175 172 164 315 7 -216 214 507 668 7 -215 219 217 509 7 -120 116 124 361 7 -386 53 391 387 7 -214 506 504 211 7 -206 214 211 259 7 -214 505 320 222 7 -216 512 223 514 7 -159 337 146 154 7 -505 507 220 222 7 -272 491 739 638 7 -355 88 468 467 7 -215 219 508 217 7 -215 509 217 210 7 -217 215 510 218 7 -215 504 210 206 7 -201 584 194 206 7 -161 304 716 321 7 -631 42 719 677 7 -147 138 269 145 7 -706 306 663 695 7 -309 562 284 637 7 -182 336 177 362 7 -365 201 196 207 7 -479 182 336 177 7 -344 201 365 207 7 -190 669 364 479 7 -614 675 428 51 7 -484 5 460 513 7 -448 445 517 44 7 -57 453 674 620 7 -356 89 520 261 7 -169 157 165 315 7 -491 404 638 706 7 -308 528 268 276 7 -221 514 526 223 7 -267 275 1 274 7 -270 635 551 396 7 -191 248 364 669 7 -113 225 106 351 7 -418 67 417 64 7 -322 362 336 331 7 -346 361 350 111 7 -168 329 161 315 7 -325 167 403 716 7 -361 116 124 111 7 -115 360 104 516 7 -224 512 332 319 7 -477 369 695 307 7 -189 190 479 336 7 -139 128 338 378 7 -338 133 376 128 7 -460 522 527 484 7 -208 397 332 526 7 -167 525 325 316 7 -294 281 305 309 7 -305 281 294 17 7 -592 522 265 6 7 -538 541 614 651 7 -309 281 280 293 7 -99 634 231 427 7 -185 327 179 317 7 -400 439 32 458 7 -602 576 396 8 7 -129 137 238 372 7 -437 637 279 534 7 -201 209 206 259 7 -319 214 344 207 7 -39 386 488 393 7 -309 305 13 600 7 -149 435 138 482 7 -259 214 211 207 7 -630 459 655 466 7 -377 134 127 226 7 -547 643 550 19 7 -655 459 69 466 7 -169 321 165 157 7 -169 168 161 315 7 -169 161 157 315 7 -635 345 481 641 7 -332 526 223 212 7 -227 313 46 631 7 -167 162 323 318 7 -311 694 624 458 7 -289 277 528 696 7 -516 446 109 119 7 -93 348 82 91 7 -66 436 252 434 7 -169 321 245 165 7 -260 477 596 695 7 -483 694 590 314 7 -321 154 163 245 7 -241 347 101 104 7 -342 154 533 157 7 -226 121 377 129 7 -98 347 360 104 7 -596 461 671 735 7 -156 500 151 334 7 -18 730 379 560 7 -99 349 105 697 7 -113 225 103 106 7 -162 173 170 168 7 -113 107 103 225 7 -123 226 135 129 7 -671 461 596 235 7 -123 127 135 226 7 -14 627 296 534 7 -188 465 182 479 7 -99 349 697 102 7 -204 193 228 197 7 -204 193 196 228 7 -180 229 171 176 7 -493 105 360 109 7 -180 174 171 229 7 -637 437 13 562 7 -160 148 230 153 7 -160 148 152 230 7 -353 98 231 97 7 -134 140 138 676 7 -81 74 72 678 7 -558 718 33 388 7 -739 566 29 272 7 -78 232 90 84 7 -127 121 377 226 7 -78 83 90 232 7 -136 233 124 130 7 -112 115 110 408 7 -136 128 124 233 7 -72 234 61 62 7 -72 608 644 234 7 -181 172 175 176 7 -640 461 671 235 7 -299 282 556 302 7 -663 307 695 369 7 -39 429 612 38 7 -612 39 38 494 7 -154 304 163 337 7 -550 273 682 545 7 -374 580 446 119 7 -137 126 238 130 7 -137 126 129 238 7 -191 239 202 196 7 -252 66 434 71 7 -191 194 202 239 7 -197 363 240 203 7 -387 385 53 428 7 -40 424 400 541 7 -101 241 110 106 7 -242 193 190 185 7 -101 104 110 241 7 -243 103 100 95 7 -193 181 242 186 7 -193 181 185 242 7 -103 243 92 95 7 -148 152 690 141 7 -103 96 92 243 7 -308 302 299 268 7 -487 607 544 244 7 -171 245 159 165 7 -400 40 426 542 7 -171 163 159 245 7 -45 246 55 448 7 -256 519 643 547 7 -45 546 55 246 7 -702 535 679 48 7 -148 137 247 142 7 -148 137 141 247 7 -179 248 191 185 7 -316 182 471 178 7 -179 183 191 248 7 -90 249 101 95 7 -609 227 352 535 7 -90 94 101 249 7 -251 468 84 467 7 -172 160 250 165 7 -172 160 164 250 7 -92 251 81 84 7 -697 354 102 111 7 -92 85 81 251 7 -68 252 78 73 7 -182 184 174 471 7 -68 71 78 252 7 -646 256 545 698 7 -126 113 253 118 7 -126 113 117 253 7 -330 479 465 183 7 -714 528 5 640 7 -9 457 461 369 7 -213 204 255 208 7 -213 204 207 255 7 -99 231 349 427 7 -206 584 200 262 7 -437 592 6 460 7 -212 257 203 208 7 -212 205 203 257 7 -462 649 560 642 7 -21 483 524 657 7 -202 259 211 207 7 -143 328 490 475 7 -202 206 211 259 7 -727 260 722 554 7 -543 558 33 707 7 -66 470 71 252 7 -75 261 86 83 7 -133 130 142 372 7 -75 82 86 261 7 -210 262 399 510 7 -210 215 262 510 7 -210 206 200 262 7 -647 627 291 296 7 -389 429 39 601 7 -24 294 309 293 7 -24 294 292 309 7 -289 528 640 498 7 -10 297 265 296 7 -10 297 295 265 7 -619 582 451 266 7 -451 593 619 266 7 -266 719 593 619 7 -70 579 82 75 7 -500 151 435 328 7 -149 500 435 482 7 -299 268 11 276 7 -133 610 134 372 7 -299 278 11 268 7 -237 375 518 463 7 -103 100 106 225 7 -356 89 358 353 7 -65 413 466 67 7 -167 177 525 316 7 -123 121 127 226 7 -147 151 152 144 7 -264 324 577 531 7 -15 256 639 591 7 -157 153 160 230 7 -167 323 166 403 7 -739 638 491 653 7 -448 246 476 428 7 -233 136 133 130 7 -318 323 403 155 7 -684 428 476 391 7 -235 640 461 685 7 -168 598 175 633 7 -458 311 32 426 7 -541 439 400 458 7 -409 318 422 155 7 -328 139 140 373 7 -584 199 262 209 7 -666 559 531 481 7 -425 693 720 570 7 -733 510 205 497 7 -479 263 189 336 7 -167 323 403 318 7 -500 422 318 475 7 -557 431 545 659 7 -620 630 674 65 7 -382 47 546 387 7 -667 375 603 237 7 -148 144 142 247 7 -419 67 58 59 7 -620 644 63 608 7 -178 480 187 465 7 -100 99 108 354 7 -474 455 451 619 7 -122 118 126 253 7 -675 582 619 385 7 -251 359 468 467 7 -164 172 250 315 7 -189 184 192 366 7 -336 184 366 331 7 -145 269 141 135 7 -486 281 600 305 7 -82 348 661 91 7 -445 614 428 448 7 -164 168 175 315 7 -259 201 202 206 7 -87 89 82 261 7 -215 206 262 209 7 -500 318 422 409 7 -415 412 77 79 7 -164 157 329 315 7 -627 592 6 437 7 -190 197 198 365 7 -210 206 262 215 7 -653 414 537 638 7 -582 684 53 428 7 -511 678 523 681 7 -134 138 135 269 7 -375 708 555 650 7 -144 153 142 658 7 -266 453 43 615 7 -360 493 109 446 7 -216 209 397 344 7 -339 147 145 340 7 -683 358 353 93 7 -151 156 161 500 7 -739 653 701 236 7 -297 628 286 522 7 -308 5 513 714 7 -579 77 82 300 7 -595 5 430 484 7 -719 42 464 440 7 -268 278 11 276 7 -268 277 278 276 7 -143 422 475 155 7 -224 326 222 319 7 -579 300 82 87 7 -18 492 499 730 7 -320 213 319 326 7 -582 57 455 451 7 -512 216 507 514 7 -301 6 519 594 7 -468 520 87 300 7 -85 80 251 300 7 -692 16 722 277 7 -282 281 305 17 7 -559 635 666 499 7 -391 58 674 679 7 -338 139 133 128 7 -580 374 378 119 7 -17 421 305 589 7 -115 114 360 446 7 -132 380 378 652 7 -69 411 466 561 7 -498 430 688 267 7 -119 580 446 493 7 -6 594 301 437 7 -161 304 318 716 7 -368 23 653 495 7 -689 570 280 450 7 -367 370 200 187 7 -584 194 206 370 7 -388 536 37 540 7 -643 481 545 550 7 -724 537 638 236 7 -454 566 29 739 7 -696 277 528 276 7 -24 309 292 293 7 -87 634 427 683 7 -292 309 280 293 7 -589 421 562 283 7 -385 440 445 441 7 -293 294 309 281 7 -727 312 260 554 7 -514 668 507 508 7 -294 284 292 309 7 -10 265 295 296 7 -522 628 286 285 7 -295 265 287 296 7 -567 606 270 499 7 -99 697 354 102 7 -296 297 265 291 7 -149 435 147 138 7 -570 600 280 450 7 -297 286 295 265 7 -487 544 35 705 7 -298 267 1 274 7 -298 267 274 288 7 -574 617 577 444 7 -279 303 450 301 7 -548 549 529 587 7 -298 275 1 267 7 -290 275 298 267 7 -589 282 17 299 7 -641 680 22 549 7 -375 667 703 237 7 -63 456 453 52 7 -316 325 166 471 7 -321 304 716 163 7 -601 39 384 718 7 -308 528 276 2 7 -561 410 466 65 7 -367 188 370 187 7 -527 285 8 662 7 -32 645 686 616 7 -422 328 435 143 7 -561 466 630 65 7 -637 450 13 437 7 -578 518 461 9 7 -576 635 551 659 7 -376 122 258 407 7 -611 37 654 583 7 -31 425 27 570 7 -283 589 308 513 7 -645 314 483 21 7 -280 309 292 637 7 -72 62 678 234 7 -735 513 457 461 7 -592 562 647 283 7 -653 638 491 414 7 -112 351 563 636 7 -717 426 311 624 7 -524 616 568 583 7 -483 314 590 21 7 -568 414 18 656 7 -6 522 265 286 7 -694 311 444 314 7 -290 484 298 715 7 -335 331 176 322 7 -730 492 602 463 7 -463 602 518 578 7 -451 593 266 52 7 -589 302 308 714 7 -565 39 612 393 7 -49 474 593 619 7 -406 405 118 407 7 -199 370 200 367 7 -9 519 559 594 7 -546 47 660 391 7 -322 633 335 553 7 -198 365 201 364 7 -256 643 698 547 7 -559 396 499 602 7 -196 204 228 365 7 -532 352 46 227 7 -178 182 465 330 7 -31 725 425 570 7 -57 234 61 644 7 -37 382 383 429 7 -47 546 387 391 7 -697 346 354 111 7 -323 173 167 599 7 -353 358 97 93 7 -672 382 45 736 7 -538 651 614 675 7 -384 718 488 442 7 -32 452 691 394 7 -449 98 97 626 7 -440 464 424 400 7 -144 140 151 333 7 -452 542 454 566 7 -496 491 307 695 7 -41 587 632 439 7 -688 498 575 430 7 -200 199 371 399 7 -488 679 48 310 7 -315 157 165 250 7 -322 169 229 176 7 -176 165 315 169 7 -176 165 172 315 7 -247 137 372 142 7 -172 176 315 175 7 -717 617 30 444 7 -304 716 403 318 7 -342 533 333 658 7 -562 13 589 457 7 -221 218 733 526 7 -574 577 19 732 7 -449 360 626 109 7 -136 398 142 658 7 -369 20 324 693 7 -18 524 567 657 7 -186 366 331 336 7 -325 304 403 155 7 -243 100 634 503 7 -355 468 87 467 7 -612 310 38 50 7 -201 199 194 584 7 -185 181 175 335 7 -520 300 579 87 7 -251 80 468 300 7 -468 520 300 76 7 -414 666 491 21 7 -724 236 638 272 7 -336 322 553 177 7 -374 652 380 381 7 -292 309 284 637 7 -315 176 322 175 7 -315 176 169 322 7 -32 694 311 458 7 -156 318 167 161 7 -666 9 531 559 7 -133 376 128 233 7 -151 334 149 147 7 -467 243 634 503 7 -634 99 357 427 7 -634 100 98 503 7 -96 243 634 359 7 -486 597 282 735 7 -531 301 519 9 7 -648 578 496 414 7 -331 184 192 180 7 -692 277 671 709 7 -467 634 355 503 7 -377 122 121 125 7 -18 648 414 492 7 -533 151 154 333 7 -150 139 328 490 7 -624 311 30 694 7 -188 183 465 479 7 -67 64 622 419 7 -67 419 622 70 7 -376 407 258 120 7 -418 67 64 622 7 -329 341 147 152 7 -151 329 147 152 7 -151 156 147 329 7 -699 388 540 28 7 -537 496 673 530 7 -59 674 630 65 7 -333 150 337 146 7 -599 330 177 316 7 -705 566 487 244 7 -151 333 328 475 7 -106 112 351 347 7 -546 391 660 246 7 -383 736 543 44 7 -72 644 61 234 7 -159 154 146 342 7 -678 729 511 73 7 -736 632 543 41 7 -500 161 475 318 7 -267 254 275 274 7 -645 568 21 524 7 -689 570 450 303 7 -333 139 140 328 7 -150 139 333 328 7 -554 556 597 596 7 -649 567 583 392 7 -132 133 652 338 7 -152 147 339 341 7 -557 551 431 659 7 -599 173 177 330 7 -154 151 475 333 7 -609 313 442 352 7 -98 683 353 231 7 -154 475 304 337 7 -257 205 489 397 7 -363 197 192 203 7 -195 189 192 363 7 -195 363 192 203 7 -89 355 356 520 7 -214 209 344 259 7 -462 560 573 271 7 -522 4 628 484 7 -341 164 329 343 7 -197 186 190 366 7 -319 255 207 344 7 -462 560 271 656 7 -21 264 590 666 7 -344 201 259 209 7 -198 201 344 209 7 -338 132 378 652 7 -118 665 405 350 7 -214 259 344 207 7 -42 440 719 677 7 -413 621 71 470 7 -374 571 446 580 7 -515 440 43 394 7 -544 721 35 705 7 -214 344 216 319 7 -214 209 216 344 7 -582 51 428 675 7 -515 677 43 440 7 -199 188 370 367 7 -491 695 404 706 7 -502 734 629 713 7 -319 214 207 320 7 -30 617 574 444 7 -459 63 625 56 7 -35 236 586 272 7 -424 651 400 541 7 -124 120 361 350 7 -151 161 475 500 7 -472 234 620 681 7 -439 694 32 458 7 -89 358 353 683 7 -288 430 267 688 7 -76 77 579 300 7 -88 468 467 84 7 -214 211 320 505 7 -113 253 665 636 7 -690 610 247 141 7 -468 232 470 84 7 -97 98 105 626 7 -84 80 73 470 7 -44 385 387 428 7 -493 114 571 446 7 -690 144 610 676 7 -351 100 106 347 7 -108 100 351 347 7 -351 100 107 225 7 -108 100 107 351 7 -113 107 225 351 7 -124 407 406 130 7 -406 405 350 118 7 -622 621 413 579 7 -106 112 347 241 7 -407 122 118 130 7 -113 665 107 351 7 -739 236 638 653 7 -406 120 405 407 7 -318 162 323 409 7 -113 636 665 351 7 -83 94 88 520 7 -303 600 450 457 7 -635 22 606 270 7 -736 632 383 543 7 -256 659 545 481 7 -283 308 290 513 7 -71 83 78 470 7 -44 543 441 445 7 -232 78 470 84 7 -78 71 470 252 7 -731 324 469 725 7 -679 702 48 310 7 -71 622 418 75 7 -215 214 216 668 7 -92 85 251 359 7 -96 85 92 359 7 -516 360 104 449 7 -154 333 146 342 7 -601 558 543 383 7 -272 739 701 236 7 -437 534 279 287 7 -88 232 468 84 7 -98 356 94 664 7 -251 80 84 468 7 -98 99 105 360 7 -92 359 243 96 7 -467 359 468 87 7 -346 114 360 108 7 -493 114 446 360 7 -360 99 346 108 7 -37 654 558 700 7 -433 105 360 493 7 -572 39 494 38 7 -571 120 116 580 7 -472 53 478 674 7 -115 360 112 104 7 -115 114 112 360 7 -362 322 174 229 7 -154 475 337 333 7 -177 322 362 336 7 -177 322 174 362 7 -188 364 199 194 7 -188 198 199 364 7 -183 194 364 188 7 -183 194 191 364 7 -392 536 388 728 7 -196 364 191 239 7 -201 364 196 239 7 -200 199 367 371 7 -364 199 194 201 7 -198 199 364 201 7 -706 306 695 312 7 -191 183 364 248 7 -182 184 471 480 7 -191 248 669 185 7 -364 669 196 191 7 -190 669 196 364 7 -224 512 223 332 7 -621 579 75 261 7 -71 622 413 418 7 -727 692 722 260 7 -623 393 50 310 7 -365 204 197 605 7 -238 137 130 372 7 -372 122 130 238 7 -133 134 125 372 7 -515 691 613 544 7 -386 615 609 53 7 -496 491 695 404 7 -173 598 633 317 7 -59 58 623 679 7 -682 732 590 444 7 -463 578 518 712 7 -496 491 404 638 7 -398 738 670 658 7 -434 436 68 438 7 -98 108 99 360 7 -231 634 98 683 7 -133 139 338 132 7 -642 568 18 656 7 -716 325 525 163 7 -425 704 720 693 7 -581 368 613 495 7 -63 52 625 56 7 -656 271 673 648 7 -680 700 707 654 7 -99 231 105 349 7 -518 430 575 498 7 -459 561 56 69 7 -590 264 577 531 7 -141 372 129 134 7 -141 137 129 372 7 -289 498 640 685 7 -601 615 384 386 7 -141 137 372 247 7 -427 634 231 683 7 -15 639 547 287 7 -390 549 587 345 7 -721 653 537 236 7 -173 330 317 177 7 -104 98 449 360 7 -371 367 187 447 7 -20 693 369 486 7 -133 139 670 738 7 -133 376 233 130 7 -133 372 376 130 7 -376 122 130 372 7 -125 122 376 372 7 -376 122 407 130 7 -456 52 451 266 7 -122 129 377 121 7 -138 652 127 380 7 -134 127 652 125 7 -372 122 129 377 7 -138 132 652 380 7 -374 125 652 381 7 -541 439 618 41 7 -427 93 349 91 7 -416 66 521 434 7 -569 352 46 607 7 -132 134 652 133 7 -257 205 397 497 7 -177 182 316 330 7 -449 98 626 360 7 -458 618 694 624 7 -577 324 303 531 7 -565 389 429 39 7 -615 44 601 441 7 -240 363 489 203 7 -610 140 134 676 7 -95 503 101 106 7 -384 601 33 615 7 -525 177 174 471 7 -437 627 534 287 7 -449 626 97 109 7 -392 37 388 536 7 -114 121 112 563 7 -195 263 184 189 7 -441 394 440 400 7 -74 410 608 681 7 -565 389 39 393 7 -85 74 80 412 7 -730 395 379 501 7 -708 730 8 602 7 -667 703 271 730 7 -388 540 37 558 7 -92 359 467 243 7 -40 502 717 629 7 -437 562 592 513 7 -337 333 146 154 7 -15 256 646 547 7 -461 640 518 685 7 -630 535 655 459 7 -488 442 48 609 7 -683 87 82 348 7 -516 360 109 446 7 -468 520 76 470 7 -694 444 590 314 7 -460 5 484 430 7 -433 697 111 346 7 -488 494 310 572 7 -450 13 437 457 7 -442 36 607 544 7 -44 445 441 385 7 -686 707 33 654 7 -374 119 380 378 7 -656 414 653 568 7 -313 43 453 609 7 -400 32 394 452 7 -198 189 402 363 7 -587 483 401 694 7 -718 558 429 540 7 -535 625 56 459 7 -673 585 530 496 7 -141 610 134 676 7 -583 495 568 642 7 -500 328 435 422 7 -391 476 660 246 7 -298 484 267 288 7 -389 47 387 386 7 -289 528 498 696 7 -672 37 700 564 7 -626 98 105 360 7 -330 183 317 479 7 -453 227 313 609 7 -350 354 346 111 7 -58 726 420 417 7 -133 140 134 610 7 -395 567 392 270 7 -655 70 59 466 7 -378 338 374 580 7 -133 610 372 142 7 -188 263 447 402 7 -610 142 247 372 7 -420 423 623 50 7 -525 163 171 245 7 -447 263 184 195 7 -698 545 25 604 7 -27 425 720 570 7 -651 541 614 445 7 -134 676 138 269 7 -29 731 629 454 7 -42 677 569 515 7 -240 397 605 208 7 -657 568 18 524 7 -503 98 94 347 7 -643 732 481 550 7 -609 384 386 488 7 -681 65 410 608 7 -443 420 393 50 7 -188 198 402 199 7 -147 144 690 676 7 -374 114 125 381 7 -383 382 389 429 7 -40 426 624 458 7 -458 40 426 400 7 -185 175 327 317 7 -147 138 676 269 7 -198 189 188 402 7 -167 169 716 525 7 -696 528 595 2 7 -616 568 495 653 7 -443 393 612 50 7 -47 60 391 420 7 -116 571 580 493 7 -41 44 445 543 7 -668 214 507 506 7 -51 538 614 675 7 -560 648 730 271 7 -391 60 58 420 7 -566 542 464 452 7 -427 485 348 91 7 -427 349 102 91 7 -80 81 729 74 7 -66 472 478 674 7 -720 280 600 281 7 -525 169 229 322 7 -580 120 116 128 7 -427 93 91 348 7 -133 139 132 140 7 -419 67 726 58 7 -44 601 441 543 7 -99 697 105 346 7 -462 495 642 656 7 -694 444 30 682 7 -544 36 368 613 7 -444 617 577 734 7 -117 129 121 723 7 -615 44 441 385 7 -527 522 285 484 7 -543 439 41 632 7 -542 426 454 629 7 -543 439 445 41 7 -666 264 590 531 7 -457 437 594 460 7 -571 120 580 376 7 -724 312 404 26 7 -609 386 53 679 7 -301 450 279 437 7 -593 719 424 619 7 -617 31 577 734 7 -121 563 117 408 7 -48 609 442 352 7 -482 435 432 143 7 -574 617 552 577 7 -517 45 41 448 7 -122 563 253 117 7 -502 617 717 734 7 -631 42 569 46 7 -356 358 86 97 7 -405 665 108 346 7 -665 253 118 405 7 -45 41 687 736 7 -361 433 116 111 7 -552 324 570 303 7 -440 266 43 615 7 -405 665 346 350 7 -118 107 665 350 7 -405 120 350 361 7 -346 405 350 361 7 -405 114 433 346 7 -361 405 433 346 7 -120 405 116 361 7 -58 419 623 726 7 -616 739 613 691 7 -580 571 446 493 7 -680 700 632 707 7 -472 681 620 674 7 -426 629 311 454 7 -543 736 41 44 7 -525 177 471 316 7 -414 307 491 666 7 -313 631 569 46 7 -74 729 511 678 7 -521 60 417 58 7 -255 204 207 365 7 -668 506 507 219 7 -490 139 328 143 7 -321 157 154 165 7 -541 40 458 400 7 -474 451 593 619 7 -59 419 623 58 7 -463 730 271 703 7 -541 439 458 618 7 -364 248 479 669 7 -77 410 76 413 7 -67 419 70 59 7 -65 410 413 66 7 -298 484 628 4 7 -515 442 677 569 7 -205 199 371 489 7 -83 621 75 261 7 -47 420 393 443 7 -416 58 391 60 7 -694 645 483 401 7 -215 508 218 217 7 -95 92 84 467 7 -88 467 95 84 7 -321 154 245 165 7 -568 414 491 21 7 -205 195 203 489 7 -572 494 310 38 7 -121 381 127 125 7 -61 474 455 451 7 -65 413 416 66 7 -65 413 67 416 7 -555 730 8 708 7 -113 118 107 665 7 -62 684 476 472 7 -718 39 572 540 7 -555 270 730 395 7 -319 255 344 397 7 -143 328 475 422 7 -481 519 531 643 7 -414 648 673 496 7 -177 182 330 479 7 -500 422 435 482 7 -330 479 317 177 7 -3 575 650 288 7 -67 521 417 58 7 -208 197 240 203 7 -67 521 58 416 7 -421 589 308 283 7 -485 634 357 427 7 -416 434 521 60 7 -416 413 67 521 7 -521 67 417 418 7 -32 311 694 645 7 -71 413 521 418 7 -260 671 235 692 7 -66 413 416 521 7 -439 618 694 458 7 -662 650 708 575 7 -109 105 360 626 7 -521 60 58 416 7 -431 641 345 635 7 -442 581 36 613 7 -575 662 518 602 7 -717 444 734 617 7 -512 319 222 216 7 -510 497 209 205 7 -87 89 520 355 7 -240 489 198 397 7 -586 537 26 724 7 -627 647 291 592 7 -43 394 710 515 7 -649 392 573 379 7 -589 735 302 714 7 -592 647 291 283 7 -209 215 216 497 7 -455 57 62 61 7 -581 613 710 495 7 -615 601 33 441 7 -446 381 374 119 7 -372 122 238 129 7 -701 705 566 35 7 -159 154 342 165 7 -409 422 482 155 7 -598 170 473 327 7 -686 707 401 439 7 -664 104 98 449 7 -437 6 594 460 7 -51 684 62 455 7 -498 595 5 430 7 -359 427 348 87 7 -270 22 551 635 7 -290 595 484 513 7 -636 113 106 351 7 -21 264 314 590 7 -335 331 322 336 7 -391 679 53 386 7 -338 376 125 374 7 -486 457 369 461 7 -559 481 666 635 7 -115 360 516 446 7 -485 427 357 91 7 -531 369 457 9 7 -730 270 8 396 7 -375 650 603 3 7 -144 533 153 658 7 -516 360 449 109 7 -576 635 659 481 7 -265 627 6 287 7 -596 735 556 597 7 -338 376 580 128 7 -610 140 144 670 7 -413 67 521 418 7 -710 384 442 718 7 -495 642 583 388 7 -148 690 247 141 7 -559 9 531 519 7 -389 44 601 386 7 -699 462 388 28 7 -265 291 592 627 7 -328 140 435 373 7 -435 373 432 143 7 -516 381 446 119 7 -149 151 435 500 7 -149 151 147 435 7 -435 151 147 140 7 -328 151 435 140 7 -140 132 435 373 7 -140 132 138 435 7 -435 132 432 373 7 -138 132 432 435 7 -694 439 32 401 7 -316 182 178 330 7 -519 6 527 594 7 -41 618 587 439 7 -683 87 89 82 7 -720 280 281 293 7 -453 57 53 582 7 -63 54 620 630 7 -431 551 635 659 7 -352 313 46 227 7 -684 53 428 391 7 -539 6 519 301 7 -632 549 680 587 7 -615 44 385 387 7 -610 140 676 144 7 -147 269 676 141 7 -541 624 618 458 7 -483 401 524 680 7 -498 518 237 575 7 -40 458 624 541 7 -256 539 519 547 7 -297 4 628 522 7 -168 473 164 175 7 -33 384 710 718 7 -134 676 269 141 7 -583 686 616 33 7 -289 498 688 254 7 -689 303 450 279 7 -440 441 615 394 7 -515 394 710 691 7 -69 70 655 466 7 -558 37 429 540 7 -356 355 94 520 7 -199 489 205 209 7 -461 5 460 640 7 -712 235 461 685 7 -618 30 587 694 7 -570 324 693 303 7 -726 64 423 417 7 -258 122 405 407 7 -572 39 488 494 7 -115 381 446 516 7 -190 186 242 336 7 -121 115 127 381 7 -245 154 159 165 7 -381 114 446 374 7 -115 114 446 381 7 -375 602 518 463 7 -85 300 251 359 7 -311 731 444 314 7 -18 499 379 730 7 -729 80 511 73 7 -613 653 544 705 7 -554 722 16 556 7 -42 677 515 440 7 -692 685 235 712 7 -14 562 647 627 7 -561 410 411 466 7 -730 375 703 463 7 -400 458 32 426 7 -214 506 505 507 7 -648 271 560 656 7 -620 63 644 456 7 -230 144 151 533 7 -466 59 630 65 7 -461 594 518 460 7 -679 453 53 609 7 -404 496 537 530 7 -630 54 674 679 7 -374 258 571 376 7 -461 714 671 735 7 -514 215 218 497 7 -304 318 403 155 7 -147 140 676 138 7 -453 679 53 674 7 -545 273 682 345 7 -601 33 441 543 7 -39 389 601 386 7 -39 601 384 386 7 -520 76 579 300 7 -256 639 539 547 7 -672 564 700 632 7 -133 125 652 338 7 -548 549 587 390 7 -48 609 352 535 7 -386 47 387 391 7 -679 535 609 48 7 -525 325 174 163 7 -692 671 235 709 7 -659 576 481 519 7 -52 313 719 266 7 -543 700 707 632 7 -637 437 562 627 7 -481 635 659 545 7 -607 244 487 569 7 -569 442 352 607 7 -15 639 286 591 7 -56 535 532 227 7 -582 684 51 455 7 -483 481 590 682 7 -529 549 34 632 7 -686 32 616 691 7 -368 462 581 699 7 -728 536 388 28 7 -246 45 517 448 7 -440 424 619 651 7 -525 229 174 322 7 -527 662 518 430 7 -525 169 171 229 7 -391 428 476 246 7 -379 567 392 395 7 -272 491 638 706 7 -576 711 8 527 7 -514 215 508 218 7 -549 641 680 345 7 -157 151 154 533 7 -342 154 333 533 7 -669 185 196 191 7 -689 303 279 19 7 -33 710 581 718 7 -371 402 199 367 7 -499 567 379 395 7 -719 464 424 440 7 -49 619 593 424 7 -564 22 611 680 7 -274 288 267 688 7 -614 445 428 675 7 -466 459 69 561 7 -307 369 531 9 7 -19 301 547 643 7 -719 677 313 631 7 -265 291 627 296 7 -545 682 481 345 7 -447 402 371 367 7 -719 677 43 313 7 -502 734 717 629 7 -47 60 660 391 7 -654 611 524 680 7 -157 533 153 230 7 -524 611 583 567 7 -230 144 533 153 7 -82 300 348 87 7 -77 466 410 413 7 -77 411 410 466 7 -90 88 249 95 7 -214 506 211 505 7 -90 94 249 88 7 -92 359 251 467 7 -71 83 470 621 7 -84 73 78 470 7 -41 445 44 517 7 -672 382 736 383 7 -545 345 481 635 7 -78 252 470 73 7 -83 78 470 232 7 -66 436 434 478 7 -136 738 398 658 7 -222 216 507 512 7 -214 504 206 211 7 -216 214 222 507 7 -215 219 509 504 7 -385 440 619 651 7 -128 139 133 738 7 -499 492 602 730 7 -66 470 252 73 7 -66 511 470 73 7 -410 80 470 511 7 -410 80 76 470 7 -66 413 470 410 7 -470 80 76 468 7 -84 80 470 468 7 -440 42 464 394 7 -261 621 579 520 7 -261 579 87 520 7 -229 180 362 322 7 -297 522 286 265 7 -654 611 583 524 7 -604 431 548 390 7 -240 397 198 605 7 -359 85 415 485 7 -36 368 581 572 7 -500 318 156 161 7 -462 642 560 656 7 -439 618 587 694 7 -561 410 65 608 7 -518 430 662 575 7 -566 42 487 244 7 -619 440 385 266 7 -278 556 302 299 7 -237 703 463 7 7 -526 497 257 397 7 -578 648 496 463 7 -453 52 313 227 7 -539 588 519 6 7 -674 681 620 65 7 -272 739 236 638 7 -57 453 53 674 7 -2 595 290 308 7 -488 48 442 36 7 -660 476 438 55 7 -596 486 369 461 7 -108 351 665 563 7 -408 112 563 636 7 -39 384 718 488 7 -252 434 68 71 7 -288 688 274 3 7 -609 43 453 615 7 -477 369 596 695 7 -60 478 391 416 7 -60 434 478 416 7 -554 260 596 695 7 -478 476 438 660 7 -19 303 301 643 7 -601 558 718 33 7 -700 654 558 707 7 -646 256 698 547 7 -400 426 32 452 7 -8 270 551 396 7 -413 67 418 622 7 -695 477 307 578 7 -275 595 267 290 7 -151 321 154 475 7 -161 475 304 321 7 -393 310 494 612 7 -665 107 346 350 7 -583 568 18 642 7 -583 616 495 33 7 -730 667 703 375 7 -526 514 497 216 7 -494 310 38 612 7 -612 39 494 393 7 -152 144 151 230 7 -342 533 658 153 7 -307 9 477 369 7 -539 287 279 547 7 -332 216 223 526 7 -306 369 596 20 7 -151 500 475 328 7 -149 409 500 482 7 -383 37 429 558 7 -307 369 324 531 7 -545 273 345 604 7 -596 486 735 597 7 -63 52 644 456 7 -391 58 416 674 7 -383 37 558 700 7 -465 194 188 370 7 -651 400 541 445 7 -31 725 577 731 7 -734 31 731 713 7 -499 270 635 606 7 -382 246 736 44 7 -566 42 244 691 7 -554 260 722 671 7 -572 540 38 699 7 -215 497 209 510 7 -731 31 725 713 7 -445 439 541 41 7 -353 93 97 231 7 -39 429 38 540 7 -570 693 600 303 7 -457 594 9 461 7 -42 515 244 691 7 -316 525 325 471 7 -167 325 166 316 7 -384 39 386 488 7 -478 436 438 476 7 -462 649 573 560 7 -252 436 68 434 7 -265 287 286 295 7 -739 566 272 701 7 -643 301 519 531 7 -482 435 138 432 7 -520 355 468 87 7 -446 493 109 119 7 -553 336 242 335 7 -733 218 510 497 7 -594 6 527 460 7 -9 559 518 594 7 -8 527 662 602 7 -20 486 596 597 7 -234 681 678 608 7 -182 184 263 336 7 -456 453 266 582 7 -554 671 722 556 7 -587 682 30 273 7 -209 199 262 399 7 -529 632 34 587 7 -209 199 399 205 7 -375 237 575 3 7 -589 562 513 283 7 -548 549 34 529 7 -431 545 345 604 7 -80 300 76 468 7 -437 627 637 534 7 -680 483 401 587 7 -520 355 88 468 7 -440 400 651 445 7 -15 639 256 547 7 -566 464 42 691 7 -87 89 261 520 7 -494 39 488 393 7 -538 619 651 675 7 -462 495 581 388 7 -133 139 140 670 7 -26 404 530 260 7 -554 671 556 596 7 -716 525 321 163 7 -453 582 385 266 7 -626 105 97 109 7 -167 173 177 599 7 -188 263 189 479 7 -368 653 613 495 7 -445 385 44 428 7 -43 442 384 609 7 -497 205 397 209 7 -424 49 651 541 7 -112 108 563 351 7 -313 442 352 569 7 -430 662 285 527 7 -621 76 579 520 7 -500 318 409 156 7 -570 600 450 303 7 -500 422 482 409 7 -87 634 683 355 7 -258 114 125 374 7 -409 318 162 156 7 -43 442 313 677 7 -54 52 453 227 7 -156 409 334 162 7 -568 657 18 414 7 -355 98 356 94 7 -306 695 596 369 7 -306 663 695 369 7 -329 156 161 151 7 -355 503 94 88 7 -54 227 453 609 7 -249 503 101 95 7 -249 94 101 503 7 -467 503 88 95 7 -467 243 503 95 7 -408 636 117 106 7 -503 100 98 347 7 -307 324 264 531 7 -256 545 698 643 7 -379 567 649 392 7 -94 347 101 503 7 -355 467 503 88 7 -542 629 454 566 7 -215 509 210 504 7 -188 480 447 263 7 -217 215 210 510 7 -454 29 314 491 7 -650 708 555 8 7 -457 460 594 461 7 -528 277 268 276 7 -74 410 412 608 7 -9 594 518 461 7 -44 601 543 383 7 -31 570 27 552 7 -578 461 477 9 7 -576 588 527 519 7 -18 567 379 499 7 -594 519 559 527 7 -231 683 93 427 7 -18 730 648 492 7 -600 450 13 309 7 -532 227 46 631 7 -513 460 461 5 7 -654 558 33 583 7 -396 635 551 576 7 -29 469 731 663 7 -177 525 174 322 7 -210 262 200 399 7 -724 537 404 638 7 -33 388 495 583 7 -731 469 29 713 7 -675 455 582 51 7 -167 716 161 318 7 -513 460 457 461 7 -732 682 481 550 7 -442 613 36 544 7 -513 437 457 460 7 -688 254 267 274 7 -287 639 286 15 7 -256 591 557 659 7 -41 614 445 448 7 -6 286 639 588 7 -629 731 29 713 7 -6 639 287 539 7 -609 488 386 679 7 -581 699 718 572 7 -265 296 627 287 7 -540 536 429 38 7 -499 270 395 730 7 -653 236 638 537 7 -169 161 321 157 7 -567 641 499 657 7 -718 39 488 572 7 -442 48 352 36 7 -694 314 483 645 7 -32 454 311 645 7 -688 575 3 288 7 -457 437 301 594 7 -30 717 444 311 7 -531 457 301 9 7 -42 440 515 394 7 -289 692 685 709 7 -587 345 483 682 7 -188 263 402 189 7 -77 413 579 70 7 -464 452 400 394 7 -526 218 497 514 7 -216 215 514 497 7 -35 721 586 236 7 -227 313 631 52 7 -122 405 253 563 7 -32 426 311 454 7 -88 520 468 232 7 -88 83 520 232 7 -520 83 470 232 7 -468 520 470 232 7 -266 719 619 440 7 -267 595 275 254 7 -73 678 523 511 7 -737 302 268 278 7 -489 363 195 203 7 -586 537 724 236 7 -550 574 19 732 7 -495 568 642 656 7 -383 700 543 632 7 -338 652 378 374 7 -287 15 286 295 7 -364 183 479 248 7 -246 448 517 44 7 -716 169 321 525 7 -389 387 44 386 7 -701 566 272 35 7 -448 445 44 428 7 -46 607 487 569 7 -601 44 615 386 7 -333 139 738 670 7 -289 692 709 277 7 -581 699 388 718 7 -434 436 438 478 7 -646 557 25 545 7 -190 336 242 553 7 -718 572 488 36 7 -257 489 203 240 7 -31 725 570 552 7 -527 285 711 8 7 -497 215 218 510 7 -594 527 518 460 7 -691 452 454 566 7 -401 32 686 439 7 -309 13 562 637 7 -167 177 169 525 7 -590 666 531 481 7 -578 666 492 559 7 -498 528 595 696 7 -674 391 478 416 7 -583 568 495 616 7 -59 58 679 674 7 -6 522 286 527 7 -483 682 694 587 7 -582 428 51 684 7 -635 481 666 641 7 -384 43 609 615 7 -547 301 519 643 7 -375 667 555 730 7 -519 559 527 576 7 -514 216 507 668 7 -543 632 707 439 7 -396 499 602 730 7 -198 402 199 489 7 -572 39 38 540 7 -655 459 56 69 7 -501 379 573 395 7 -630 54 459 63 7 -714 735 737 671 7 -426 717 311 629 7 -464 42 691 394 7 -156 500 334 409 7 -393 679 391 386 7 -266 582 385 619 7 -566 452 464 691 7 -553 335 175 633 7 -553 242 185 335 7 -383 382 736 44 7 -651 445 614 675 7 -629 734 731 713 7 -442 515 613 544 7 -114 571 120 116 7 -53 391 674 679 7 -641 22 606 635 7 -635 22 431 641 7 -693 369 457 303 7 -397 255 605 208 7 -662 285 8 650 7 -185 553 175 317 7 -157 230 151 533 7 -342 157 153 165 7 -342 154 157 165 7 -99 697 346 354 7 -338 133 125 376 7 -186 331 335 336 7 -499 270 396 635 7 -348 87 427 683 7 -486 600 13 305 7 -659 588 576 519 7 -630 459 561 63 7 -507 668 219 508 7 -28 728 573 649 7 -128 338 378 580 7 -705 653 721 701 7 -488 572 48 36 7 -720 693 704 600 7 -552 324 303 577 7 -18 567 499 657 7 -113 253 118 665 7 -445 439 400 541 7 -32 452 454 691 7 -597 704 486 282 7 -388 536 540 28 7 -313 52 453 266 7 -705 691 244 544 7 -289 237 688 498 7 -479 183 317 248 7 -463 375 703 237 7 -215 209 262 510 7 -646 557 545 256 7 -189 364 188 479 7 -540 536 38 28 7 -413 76 470 410 7 -317 598 175 327 7 -364 183 188 479 7 -343 162 170 168 7 -74 80 410 511 7 -21 568 657 524 7 -587 549 680 345 7 -725 324 570 552 7 -32 454 645 616 7 -553 633 317 177 7 -510 205 209 399 7 -317 598 633 175 7 -646 545 25 698 7 -568 645 21 491 7 -176 180 322 331 7 -256 557 545 659 7 -575 650 708 375 7 -342 533 153 157 7 -237 518 375 575 7 -635 22 551 431 7 -157 152 151 230 7 -707 654 401 680 7 -499 270 730 396 7 -190 185 669 553 7 -479 248 553 669 7 -553 248 317 185 7 -479 553 317 177 7 -479 336 553 177 7 -190 336 553 479 7 -321 157 151 154 7 -49 651 619 424 7 -96 634 485 359 7 -100 99 357 634 7 -456 453 582 57 7 -354 100 99 357 7 -479 248 317 553 7 -147 144 152 690 7 -190 242 185 553 7 -308 5 595 513 7 -684 51 476 428 7 -690 147 676 141 7 -96 634 357 485 7 -18 567 649 379 7 -20 369 596 486 7 -633 168 322 175 7 -642 583 388 649 7 -96 100 634 243 7 -96 100 357 634 7 -6 286 265 287 7 -18 657 499 492 7 -175 335 176 322 7 -481 559 531 519 7 -175 181 176 335 7 -175 335 322 633 7 -730 270 555 8 7 -519 481 559 576 7 -567 22 606 641 7 -388 495 642 462 7 -185 335 175 553 7 -251 300 468 359 7 -26 312 260 727 7 -685 709 640 289 7 -412 410 561 608 7 -382 389 429 565 7 -463 492 602 578 7 -718 488 442 36 7 -739 454 491 29 7 -306 663 369 20 7 -600 693 457 303 7 -582 57 684 455 7 -552 303 689 19 7 -209 199 201 584 7 -148 144 690 152 7 -591 711 551 659 7 -683 98 89 355 7 -513 562 592 283 7 -562 305 13 309 7 -456 582 451 57 7 -188 447 480 187 7 -188 367 447 187 7 -447 188 402 367 7 -640 528 5 498 7 -369 324 303 693 7 -442 36 352 607 7 -66 681 523 472 7 -30 574 682 444 7 -37 536 429 540 7 -570 720 600 693 7 -680 564 632 700 7 -122 121 563 117 7 -57 53 472 674 7 -603 667 555 375 7 -562 437 457 513 7 -189 184 336 263 7 -356 89 261 358 7 -199 194 584 370 7 -567 22 392 270 7 -329 168 343 164 7 -649 583 388 392 7 -67 58 59 416 7 -510 209 262 399 7 -368 495 581 462 7 -235 671 640 709 7 -33 601 384 718 7 -8 396 551 576 7 -221 733 212 526 7 -177 633 168 322 7 -643 303 301 531 7 -524 611 567 680 7 -212 526 257 208 7 -584 199 200 262 7 -552 303 570 689 7 -188 465 480 182 7 -199 370 584 200 7 -563 253 665 405 7 -66 65 410 681 7 -136 128 133 738 7 -670 139 140 333 7 -208 526 332 212 7 -345 481 483 682 7 -197 240 198 605 7 -730 375 602 708 7 -583 37 558 388 7 -456 52 266 453 7 -609 488 679 48 7 -445 385 428 675 7 -543 707 686 439 7 -501 560 730 271 7 -392 728 388 649 7 -6 286 287 639 7 -345 682 587 273 7 -128 136 133 233 7 -619 719 424 440 7 -324 303 531 369 7 -670 140 144 333 7 -303 369 457 531 7 -578 9 477 307 7 -483 645 21 524 7 -87 683 89 355 7 -32 454 616 691 7 -680 401 524 654 7 -726 423 420 417 7 -543 707 33 686 7 -550 273 545 604 7 -513 283 592 715 7 -308 714 513 589 7 -308 5 714 528 7 -531 303 301 457 7 -460 518 640 430 7 -442 515 710 613 7 -254 498 688 267 7 -716 169 161 321 7 -257 733 205 497 7 -567 606 499 641 7 -500 422 475 328 7 -714 5 513 461 7 -668 215 508 514 7 -683 93 353 231 7 -450 437 301 457 7 -588 711 659 576 7 -70 622 579 75 7 -393 679 488 310 7 -547 301 539 519 7 -587 682 694 30 7 -431 635 345 545 7 -150 738 146 333 7 -624 717 30 311 7 -578 712 477 461 7 -144 533 658 333 7 -712 463 685 518 7 -553 633 175 317 7 -559 635 499 396 7 -666 657 492 499 7 -645 491 314 21 7 -284 294 305 309 7 -680 22 567 641 7 -711 8 551 576 7 -524 583 18 567 7 -13 437 457 562 7 -724 537 26 404 7 -524 568 18 583 7 -48 488 310 572 7 -578 712 461 518 7 -583 567 611 392 7 -114 258 405 120 7 -26 404 260 312 7 -520 94 88 355 7 -67 416 59 65 7 -630 54 535 459 7 -554 312 260 695 7 -613 739 653 705 7 -591 639 286 588 7 -6 286 588 527 7 -278 302 268 299 7 -588 286 711 527 7 -576 588 711 527 7 -182 184 336 362 7 -17 305 282 589 7 -52 227 532 631 7 -309 450 13 637 7 -368 699 581 572 7 -709 528 640 289 7 -709 671 640 528 7 -303 457 450 301 7 -709 671 528 277 7 -308 714 268 528 7 -575 650 375 3 7 -94 104 101 347 7 -19 303 279 301 7 -421 284 562 283 7 -366 184 192 331 7 -596 461 369 477 7 -385 440 651 445 7 -300 359 661 348 7 -18 648 560 656 7 -735 714 513 461 7 -112 114 563 108 7 -589 513 457 735 7 -13 589 457 735 7 -475 333 328 150 7 -312 404 260 695 7 -592 283 291 715 7 -686 707 654 401 7 -290 484 715 513 7 -41 445 517 448 7 -347 112 108 360 7 -291 592 297 265 7 -592 522 297 265 7 -385 619 675 651 7 -513 283 715 290 7 -291 4 297 592 7 -592 4 297 522 7 -660 476 55 246 7 -56 227 532 52 7 -484 460 592 513 7 -478 476 660 391 7 -715 484 592 513 7 -298 484 4 715 7 -66 413 521 71 7 -401 645 483 524 7 -682 574 732 444 7 -621 622 75 579 7 -93 683 82 348 7 -284 562 305 421 7 -583 558 33 388 7 -18 492 414 657 7 -231 93 97 105 7 -18 648 656 414 7 -47 389 565 393 7 -257 397 240 208 7 -696 595 254 2 7 -679 630 702 59 7 -707 680 401 587 7 -301 594 519 9 7 -301 457 594 9 7 -464 542 400 452 7 -595 430 267 484 7 -518 559 578 602 7 -588 6 527 519 7 -430 288 285 662 7 -506 219 220 507 7 -284 305 562 309 7 -282 281 486 305 7 -2 595 275 290 7 -440 615 43 394 7 -638 491 414 496 7 -473 168 170 598 7 -173 598 317 179 7 -173 170 598 179 7 -170 173 598 168 7 -256 519 481 643 7 -634 98 355 503 7 -168 473 175 598 7 -385 582 428 675 7 -693 486 704 600 7 -598 473 175 327 7 -485 634 427 359 7 -190 189 366 336 7 -343 168 170 473 7 -637 562 14 627 7 -59 679 623 702 7 -661 77 79 415 7 -260 235 596 477 7 -538 49 651 619 7 -709 277 528 289 7 -492 578 648 414 7 -7 692 685 289 7 -718 699 540 572 7 -685 7 289 237 7 -578 559 492 602 7 -605 397 198 344 7 -397 209 198 344 7 -629 454 566 29 7 -42 677 631 569 7 -576 602 527 8 7 -576 559 527 602 7 -198 201 365 344 7 -518 559 602 527 7 -557 431 25 545 7 -9 559 578 518 7 -681 234 620 608 7 -63 561 630 620 7 -344 201 207 259 7 -620 54 674 630 7 -605 204 255 365 7 -605 365 255 344 7 -198 344 365 605 7 -255 365 207 344 7 -356 520 94 83 7 -573 501 12 271 7 -705 721 35 701 7 -228 204 197 365 7 -684 57 62 455 7 -258 114 405 122 7 -289 498 254 696 7 -37 700 564 654 7 -462 388 581 699 7 -457 600 13 486 7 -733 218 497 526 7 -631 677 313 569 7 -98 89 356 353 7 -548 529 34 587 7 -464 424 400 542 7 -580 376 374 571 7 -114 446 374 571 7 -384 615 609 386 7 -98 89 355 356 7 -355 98 94 503 7 -562 457 589 513 7 -67 70 466 59 7 -360 105 346 99 7 -114 120 405 116 7 -398 133 142 670 7 -73 511 523 66 7 -563 117 636 253 7 -556 722 16 737 7 -22 392 564 611 7 -52 631 719 313 7 -133 140 610 670 7 -277 737 278 16 7 -539 437 279 287 7 -461 714 5 640 7 -646 591 557 256 7 -663 324 731 264 7 -383 700 558 543 7 -167 525 716 325 7 -66 410 470 511 7 -496 404 695 712 7 -256 588 519 539 7 -77 415 661 300 7 -99 108 354 346 7 -440 385 615 441 7 -66 65 681 674 7 -710 615 394 43 7 -234 62 678 681 7 -474 538 455 619 7 -615 387 385 53 7 -386 387 615 53 7 -256 588 539 639 7 -615 385 453 53 7 -301 437 279 539 7 -615 441 33 394 7 -496 578 712 695 7 -685 235 640 709 7 -736 45 517 246 7 -246 448 44 428 7 -72 234 678 608 7 -502 31 734 713 7 -512 216 223 332 7 -205 195 489 371 7 -57 234 620 472 7 -703 7 585 463 7 -673 463 496 648 7 -674 53 478 391 7 -66 410 511 681 7 -399 199 371 205 7 -577 303 19 732 7 -589 299 421 308 7 -732 303 643 531 7 -574 552 19 577 7 -577 303 732 531 7 -19 303 643 732 7 -257 240 203 208 7 -208 197 605 240 7 -590 531 732 481 7 -727 722 16 554 7 -721 537 586 236 7 -384 615 710 43 7 -483 694 682 590 7 -402 371 199 489 7 -376 258 571 120 7 -188 480 263 182 7 -538 49 541 651 7 -29 731 454 314 7 -673 463 585 496 7 -463 7 585 712 7 -382 546 246 387 7 -555 730 667 12 7 -589 714 513 735 7 -444 731 577 314 7 -287 627 6 437 7 -522 628 285 484 7 -484 285 527 430 7 -383 672 700 632 7 -28 649 573 462 7 -169 525 171 245 7 -554 596 597 306 7 -554 260 671 596 7 -212 733 257 526 7 -703 463 585 673 7 -498 595 254 696 7 -595 430 498 267 7 -216 209 497 397 7 -47 393 565 443 7 -425 20 704 693 7 -54 625 459 63 7 -257 205 203 489 7 -718 699 388 540 7 -63 625 52 54 7 -333 144 670 658 7 -696 276 528 2 7 -431 641 549 345 7 -125 258 374 376 7 -460 527 518 430 7 -57 644 61 451 7 -280 450 600 309 7 -739 454 645 491 7 -710 613 691 616 7 -600 281 280 309 7 -655 466 59 630 7 -313 352 46 569 7 -406 120 350 405 7 -587 707 439 401 7 -689 279 450 280 7 -454 491 314 645 7 -710 613 616 495 7 -177 182 174 471 7 -442 581 613 710 7 -151 147 140 144 7 -679 54 535 630 7 -630 459 466 561 7 -437 513 592 460 7 -549 564 34 632 7 -133 610 142 670 7 -653 673 537 414 7 -613 653 616 495 7 -402 189 195 363 7 -177 168 169 322 7 -66 674 681 472 7 -14 562 284 647 7 -235 461 596 477 7 -518 662 527 602 7 -385 582 53 428 7 -44 383 389 601 7 -342 333 146 658 7 -18 583 642 649 7 -77 413 76 579 7 -595 5 484 513 7 -62 51 476 684 7 -359 634 427 87 7 -359 467 634 87 7 -87 467 634 355 7 -640 498 5 430 7 -535 54 625 459 7 -655 535 56 459 7 -6 301 539 437 7 -80 300 77 76 7 -23 673 653 656 7 -58 726 623 420 7 -535 227 56 625 7 -638 414 537 496 7 -54 227 535 625 7 -434 60 478 660 7 -546 660 55 246 7 -82 77 661 300 7 -524 401 686 654 7 -496 578 307 414 7 -74 80 511 729 7 -469 324 731 663 7 -671 737 528 277 7 -43 442 677 515 7 -214 507 505 222 7 -693 600 457 486 7 -20 704 693 486 7 -336 322 335 553 7 -461 460 518 640 7 -5 460 640 430 7 -484 4 592 522 7 -690 676 610 141 7 -502 31 617 734 7 -511 80 470 73 7 -341 147 340 334 7 -41 587 34 632 7 -534 627 296 287 7 -43 710 442 515 7 -637 279 450 437 7 -393 488 679 386 7 -57 644 451 456 7 -59 416 674 65 7 -28 462 388 649 7 -322 633 553 177 7 -460 522 592 6 7 -181 185 242 335 7 -265 592 6 627 7 -712 461 235 477 7 -186 331 176 335 7 -590 577 264 314 7 -645 454 311 314 7 -379 18 560 649 7 -32 645 694 401 7 -462 495 656 23 7 -391 546 387 246 7 -402 371 195 447 7 -562 592 627 437 7 -739 645 568 491 7 -452 426 32 454 7 -322 180 362 331 7 -595 498 254 267 7 -6 522 527 460 7 -478 60 391 660 7 -562 284 647 283 7 -649 18 560 642 7 -657 483 524 641 7 -322 168 169 315 7 -452 464 691 394 7 -736 45 41 517 7 -485 415 359 661 7 -122 114 405 563 7 -569 515 607 244 7 -499 567 395 270 7 -668 214 506 504 7 -677 442 313 569 7 -264 307 666 491 7 -29 663 731 264 7 -637 562 284 14 7 -345 641 483 481 7 -264 666 21 491 7 -629 734 717 311 7 -6 639 539 588 7 -59 679 630 674 7 -601 429 39 718 7 -41 34 687 632 7 -460 484 527 430 7 -82 661 79 91 7 -18 567 583 649 7 -459 63 56 561 7 -567 22 270 606 7 -573 379 501 560 7 -657 524 567 641 7 -550 682 481 545 7 -641 499 635 606 7 -368 23 721 653 7 -70 413 579 622 7 -236 701 721 653 7 -74 511 681 678 7 -544 653 721 705 7 -589 282 299 302 7 -47 391 393 420 7 -45 672 687 34 7 -430 484 285 288 7 -559 635 396 576 7 -491 29 314 264 7 -653 414 491 568 7 -739 653 491 568 7 -712 461 518 685 7 -485 415 661 91 7 -568 21 657 414 7 -653 739 701 705 7 -138 134 127 652 7 -215 668 219 504 7 -280 450 309 637 7 -64 67 726 419 7 -552 19 577 303 7 -623 419 423 726 7 -216 215 668 514 7 -398 133 670 738 7 -289 685 237 498 7 -215 214 668 504 7 -40 426 629 717 7 -308 268 299 276 7 -469 20 663 306 7 -500 149 334 409 7 -2 254 275 595 7 -20 704 486 597 7 -257 489 240 397 7 -557 591 551 659 7 -712 235 692 260 7 -649 379 573 560 7 -173 168 177 633 7 -515 691 710 613 7 -579 77 70 82 7 -117 121 408 723 7 -666 590 483 481 7 -21 666 483 657 7 -21 590 483 666 7 -666 483 641 481 7 -657 483 641 666 7 -547 639 539 287 7 -122 114 125 258 7 -321 154 475 304 7 -657 666 414 21 7 -492 666 414 657 7 -492 578 414 666 7 -666 307 531 9 7 -578 307 666 9 7 -666 307 264 531 7 -305 294 284 421 7 -556 737 16 278 7 -277 722 737 16 7 -714 737 268 528 7 -324 369 663 20 7 -177 169 525 322 7 -548 549 390 431 7 -114 121 125 381 7 -136 738 658 146 7 -736 517 44 246 7 -592 291 4 715 7 -528 737 268 277 7 -77 85 415 300 7 -721 23 537 653 7 -45 687 41 34 7 -346 114 433 360 7 -401 32 645 686 7 -725 693 570 324 7 -702 535 655 630 7 -393 420 623 50 7 -121 114 125 122 7 -54 535 227 609 7 -638 496 537 404 7 -594 559 518 527 7 -59 630 702 655 7 -385 651 675 445 7 -412 410 77 411 7 -348 683 427 93 7 -591 659 588 711 7 -273 574 550 682 7 -449 98 664 97 7 -559 576 396 602 7 -591 711 588 286 7 -715 484 4 592 7 -640 528 671 714 7 -515 394 691 42 7 -271 703 673 463 7 -543 439 441 445 7 -708 8 662 602 7 -688 237 575 498 7 -453 54 679 674 7 -498 528 5 595 7 -538 455 675 51 7 -691 454 739 566 7 -716 167 403 318 7 -152 147 141 339 7 -262 199 200 399 7 -619 455 451 582 7 -478 53 684 391 7 -634 98 683 355 7 -683 358 93 82 7 -680 345 483 587 7 -680 564 654 611 7 -570 280 600 720 7 -524 680 567 641 7 -336 186 242 335 7 -402 188 199 367 7 -29 706 491 272 7 -577 731 324 264 7 -260 671 692 722 7 -577 725 324 731 7 -404 530 537 26 7 -636 253 665 563 7 -538 455 619 675 7 -384 442 488 609 7 -559 499 492 602 7 -174 525 163 171 7 -23 271 673 656 7 -121 112 563 408 7 -454 731 311 314 7 -690 144 247 610 7 -80 77 410 76 7 -640 518 498 430 7 -559 481 635 576 7 -577 731 264 314 7 -601 429 718 558 7 -614 445 541 41 7 -390 549 345 431 7 -408 636 563 117 7 -290 308 595 513 7 -672 564 632 34 7 -308 595 5 528 7 -611 22 567 680 7 -601 383 429 558 7 -583 654 686 33 7 -375 730 555 708 7 -256 481 545 643 7 -441 543 686 439 7 -441 33 686 543 7 -441 33 394 686 7 -686 32 394 400 7 -441 686 394 400 7 -439 686 441 400 7 -439 32 686 400 7 -687 672 632 34 7 -653 616 568 739 7 -524 686 616 583 7 -524 654 686 583 7 -686 616 645 524 7 -401 686 645 524 7 -556 671 722 737 7 -724 272 638 706 7 -663 695 307 491 7 -670 144 142 658 7 -27 280 720 293 7 -705 691 544 613 7 -563 114 121 122 7 -150 139 738 333 7 -566 739 705 701 7 -601 33 543 558 7 -256 659 481 519 7 -44 387 615 386 7 -610 144 142 670 7 -604 431 390 345 7 -29 264 731 314 7 -463 712 585 496 7 -565 39 429 612 7 -573 560 501 271 7 -648 730 271 463 7 -527 285 286 711 7 -368 721 544 653 7 -434 66 478 416 7 -163 716 325 304 7 -679 535 702 630 7 -705 244 487 544 7 -478 684 476 391 7 -496 491 414 307 7 -74 681 608 678 7 -656 673 653 414 7 -387 391 246 428 7 -387 53 391 428 7 -641 549 22 431 7 -156 318 162 167 7 -382 246 44 387 7 -80 81 84 729 7 -71 66 434 521 7 -739 691 566 705 7 -266 440 43 719 7 -640 518 685 498 7 -197 363 198 240 7 -125 127 652 381 7 -325 716 403 304 7 -136 133 398 738 7 -728 392 573 649 7 -261 579 75 82 7 -414 673 537 496 7 -99 634 98 231 7 -19 301 279 547 7 -168 167 169 161 7 -31 725 552 577 7 -562 592 647 627 7 -319 208 397 332 7 -319 208 255 397 7 -714 302 268 737 7 -714 737 528 671 7 -706 695 404 312 7 -157 329 151 152 7 -397 216 332 526 7 -497 216 397 526 7 -319 397 216 332 7 -319 344 216 397 7 -35 236 272 701 7 -188 182 263 479 7 -563 114 405 108 7 -382 246 45 736 7 -430 288 662 575 7 -616 568 645 524 7 -680 564 700 654 7 -209 198 489 397 7 -585 7 692 712 7 -549 564 632 680 7 -472 62 234 681 7 -393 488 494 310 7 -271 463 673 648 7 -679 58 393 391 7 -693 725 425 20 7 -609 615 453 53 7 -300 359 348 87 7 -586 236 724 272 7 -569 515 442 607 7 -736 672 383 632 7 -732 577 590 444 7 -43 442 609 313 7 -667 271 12 730 7 -419 64 423 726 7 -484 430 267 288 7 -736 687 632 41 7 -632 680 707 587 7 -632 707 439 587 7 -596 461 735 486 7 -499 395 379 730 7 -29 469 663 706 7 -609 313 352 227 7 -589 302 299 308 7 -169 321 525 245 7 -442 515 544 607 7 -147 145 340 149 7 -710 686 394 33 7 -616 686 710 33 7 -710 495 616 33 7 -581 495 710 33 7 -221 526 212 223 7 -161 167 169 716 7 -710 615 33 394 7 -737 556 302 278 7 -384 615 33 710 7 -710 384 43 442 7 -727 692 16 722 7 -685 518 237 498 7 -686 691 710 394 7 -686 691 616 710 7 -404 530 260 712 7 -555 395 730 12 7 -12 271 501 730 7 -260 671 596 235 7 -620 561 630 65 7 -723 121 408 123 7 -706 404 638 724 7 -476 684 478 472 7 -682 574 550 732 7 -723 129 121 123 7 -578 463 496 712 7 -549 22 564 680 7 -462 388 649 642 7 -144 151 533 333 7 -620 608 561 65 7 -379 392 573 395 7 -585 712 530 496 7 -161 475 318 304 7 -469 306 663 706 7 -629 731 311 454 7 -424 440 400 651 7 -212 733 205 257 7 -629 731 734 311 7 -49 538 474 619 7 -15 591 646 256 7 -243 467 634 359 7 -578 477 712 695 7 -663 706 695 491 7 -732 590 481 682 7 -712 7 692 685 7 -353 98 97 356 7 -472 476 436 478 7 -590 577 732 531 7 -525 321 163 245 7 -722 277 671 692 7 -560 18 730 648 7 -29 706 663 491 7 -469 20 324 663 7 -324 369 307 663 7 -264 663 324 307 7 -57 53 684 472 7 -712 477 260 695 7 -611 37 583 392 7 -712 530 260 692 7 -37 564 611 654 7 -530 585 692 712 7 -144 147 140 676 7 -491 29 264 663 7 -59 58 674 416 7 -491 663 264 307 7 -39 429 540 718 7 -231 93 349 427 7 -138 132 134 652 7 -583 37 654 558 7 -99 98 105 231 7 -685 692 235 709 7 -581 718 442 36 7 -581 572 718 36 7 -603 667 12 555 7 -496 530 404 712 7 -706 312 404 724 7 -469 20 725 324 7 -359 300 468 87 7 -57 62 234 472 7 -495 653 656 23 7 -375 730 602 463 7 -736 41 44 517 7 -534 627 637 14 7 -42 515 569 244 7 -305 294 421 17 7 -737 278 268 277 7 -575 237 688 3 7 -435 140 147 138 7 -559 666 492 499 7 -666 641 657 499 7 -447 263 195 402 7 -635 641 666 499 7 -714 735 302 737 7 -368 653 544 613 7 -577 725 552 324 7 -495 653 568 656 7 -305 281 600 309 7 -98 683 89 353 7 -620 453 456 57 7 -462 656 271 23 7 -311 734 717 444 7 -526 397 257 208 7 -529 549 632 587 7 -221 218 526 514 7 -705 566 244 691 7 -582 57 53 684 7 -472 53 684 478 7 -656 648 673 414 7 -453 54 674 620 7 -45 672 736 687 7 -735 597 282 556 7 -152 147 690 141 7 -63 52 453 54 7 -117 129 122 121 7 -444 734 577 731 7 -46 569 487 42 7 -643 550 698 547 7 -613 581 36 368 7 -589 282 302 735 7 -305 735 282 589 7 -305 486 282 735 7 -404 260 695 712 7 -486 735 457 461 7 -486 13 457 735 7 -305 13 735 589 7 -596 735 671 556 7 -40 424 542 400 7 -735 282 302 556 7 -737 735 302 556 7 -256 588 639 591 7 -472 681 523 62 7 -486 305 13 735 7 -645 311 694 314 7 -739 29 491 272 7 -73 66 523 436 7 -678 62 523 681 7 -82 77 79 661 7 -648 730 463 492 7 -569 42 244 487 7 -680 641 483 345 7 -543 700 558 707 7 -383 37 700 672 7 -575 288 662 650 7 -739 613 691 705 7 -711 551 659 576 7 -616 454 739 691 7 -256 659 519 588 7 -604 345 390 273 7 -256 659 588 591 7 -616 454 645 739 7 -27 280 570 720 7 -719 440 43 677 7 - - -Normals -260 --4.69915893729967e-05 -3.69203765717714e-07 0.999999998895827 -3.00183447058927e-07 0.999999999967231 8.09002099651578e-06 -5.19519060610554e-05 -5.64497865199658e-07 -0.99999999865034 --1.21613521199807e-06 -0.999999999978473 6.44781516210081e-06 -1.05309330898451e-06 0.999999999969721 7.71039084691783e-06 --8.54784324821877e-05 -1.85754989580413e-06 0.999999996344994 --6.75984711722765e-07 -0.999999999983381 5.72547195723809e-06 -8.63854953521258e-05 2.77655273279942e-07 -0.999999996268735 --0.000112216419193519 3.85115745119033e-07 0.999999993703664 -1.2817822739663e-06 0.999999999974094 7.08298114003424e-06 -0.00010905679088338 3.96982027526876e-06 -0.999999994045429 --1.12384531158682e-06 -0.99999999999004 4.31936178913896e-06 -5.20166859140282e-07 0.999999999986146 5.23819068635355e-06 --0.000125053882315384 -8.07554606216145e-07 0.999999992180437 -0.000130339713088446 7.85463740257312e-07 -0.999999991505471 --1.40663653929028e-07 -0.999999999993897 3.49082594354812e-06 --0.000147161263020087 -1.66689866389425e-06 0.999999989170392 -9.01184264499525e-08 0.999999999990685 4.31527102268963e-06 -0.00014379810154768 -9.38003957624781e-07 -0.999999989660613 -2.18990918602327e-07 -0.99999999999532 3.05151442836016e-06 --0.000158079202700042 -3.62629809642021e-07 0.999999987505417 --2.89280713327648e-07 0.999999999993862 3.49184375210041e-06 -0.000159131751678495 6.37243870426213e-07 -0.99999998733834 --3.50097026140041e-07 -0.9999999999989 1.44157567854414e-06 --0.00016737665629902 -1.0402674189792e-06 0.999999985991986 --2.36645387079348e-07 0.999999999995686 2.92780195923083e-06 -0.000167956283779042 9.06585665872257e-07 -0.999999985894932 -3.68893778798901e-07 -0.999999999999453 9.79041272483036e-07 --0.000175044495740033 -9.69428421690629e-07 0.999999984679242 --8.12189075763854e-07 0.999999999996871 2.36614647206311e-06 -0.000174888933013576 8.98490237785059e-07 -0.999999984706527 -2.50207831531763e-07 -0.999999999999755 6.54563431511342e-07 --5.79824561531865e-07 0.999999999998007 1.9105240884598e-06 --0.000179412349274095 -1.39087942790837e-06 0.999999983904637 -0.000179742626556185 7.39951482174004e-07 -0.99999998384602 -3.33050688307593e-07 -0.999999999999943 5.67805600349373e-08 --5.23156518758702e-07 0.999999999998696 1.52766808903451e-06 --0.000183757600990064 -8.89252456113448e-07 0.999999983116177 -0.000183045634133003 7.95905200440384e-07 -0.999999983246831 -3.32988285903981e-07 -0.99999999999993 -1.70312267823294e-07 --5.09033207752742e-07 0.999999999999037 1.29142875330379e-06 --0.000185156279098081 -7.57363446763315e-07 0.999999982858289 -0.000184892593752968 9.44901864487772e-07 -0.999999982906918 -4.53104433409237e-07 -0.999999999999785 -4.75130921287995e-07 --4.16120231989429e-07 0.999999999999276 1.12865012634882e-06 --0.000185743892872997 -1.00712240697072e-06 0.999999982749096 -0.000185819911381169 9.42800933186457e-07 -0.999999982735036 -4.05127758936971e-07 -0.999999999999651 -7.30346636164415e-07 --5.0003418944629e-07 0.999999999999351 1.02377154628165e-06 --0.000186020055700753 -8.93330411002527e-07 0.99999998269787 -0.000186036524114885 8.78682964638225e-07 -0.99999998269482 -3.96419872169029e-07 -0.999999999999559 -8.51332959238085e-07 --4.28388615450934e-07 0.999999999999511 8.91460134484877e-07 --0.00018577496488494 -9.36116963016491e-07 0.999999982743393 -0.000185796425085677 8.97317531983583e-07 -0.999999982739441 -4.16663646667366e-07 -0.999999999999483 -9.27256685474619e-07 --3.90178530839771e-07 0.999999999999556 8.57638029727352e-07 --0.000185420041261753 -9.40543213959236e-07 0.999999982809262 -0.000185405171851387 9.19125289699986e-07 -0.999999982812039 -3.86590712862595e-07 -0.999999999999458 -9.67283687382853e-07 --3.70874930802007e-07 0.999999999999571 8.49391505802672e-07 --0.000185012478197649 -9.27294649600842e-07 0.999999982884761 -0.000184989667838991 9.08121931391572e-07 -0.999999982888999 -3.7910202964887e-07 -0.999999999999461 -9.66753009065329e-07 --3.80768254389339e-07 0.999999999999556 8.62491552745485e-07 --0.000184688500235892 -9.23272755700333e-07 0.999999982944653 -0.000184655209955266 9.10972002330395e-07 -0.999999982950812 -3.73741526313686e-07 -0.999999999999464 -9.65209877236989e-07 --0.000184501250654641 -9.20247317054935e-07 0.999999982979221 --3.76581183083089e-07 0.999999999999547 8.7403314520244e-07 -0.000184500106631382 9.06144375367684e-07 -0.999999982979445 -3.81851354110401e-07 -0.999999999999485 -9.40659849741928e-07 --4.29908627799546e-05 -1.3118216367588e-06 0.999999999075033 --2.51077968408055e-05 -2.84658080498354e-07 0.999999999684759 -8.08095036609374e-07 0.999999999965571 8.25864092864132e-06 --7.60696706762307e-05 -3.6003073179313e-06 0.999999997100221 --3.6088071560764e-07 -0.999999999984807 5.50058754520992e-06 -7.73960414086427e-05 2.6689856299655e-06 -0.999999997001365 --2.83547568257592e-05 1.75146549274412e-06 0.99999999959647 -3.28300313554099e-05 -1.86411473979399e-06 -0.999999999459357 -2.83366469395758e-05 -6.52842831901613e-06 -0.999999999577207 -1.38687794968584e-06 -0.999999999988126 4.67165179736917e-06 --1.3836148539987e-06 -0.999999999993479 3.3357344608775e-06 -1 -1.17906985174513e-14 -4.90932795029173e-15 -1 -8.89057902989789e-17 5.93603369276479e-15 -1.88467137506702e-07 0.999999999976051 6.91834041699887e-06 -2.10370356039109e-06 0.999999999982119 5.59791192512548e-06 -2.77883363785825e-05 5.2018481169632e-06 -0.999999999600375 --1.3030423659526e-06 0.999999999982275 5.80962396178635e-06 --3.20071683621607e-05 -1.9100386865941e-08 0.99999999948777 -1 6.06038896971545e-15 -8.94039748862242e-17 -1 -1.11597416567588e-15 -5.502625282781e-15 --0.00018588974242974 -9.21571334936368e-07 0.999999982722077 --8.56843260549454e-07 -0.999999999984645 5.47503144358675e-06 -1 -1.3768936454687e-15 -4.72178586765772e-15 --0.000128389225200361 -2.30530637737536e-06 0.999999991755446 --7.89416908172088e-07 -0.999999999986865 5.06431861643644e-06 -0.000184454796411527 9.09559164998417e-07 -0.9999999829878 --3.91509751762142e-07 0.999999999999548 8.66474850065876e-07 --0.000185626641324526 -9.22530262655985e-07 0.999999982770949 -0.000184451672109594 9.12759436201852e-07 -0.999999982988374 -0.000185319456838092 8.69948713358044e-07 -0.999999982827971 --3.75351738520052e-07 0.999999999999569 8.49699127363446e-07 -3.86592360090278e-07 -0.999999999999447 -9.77781350913526e-07 -3.74625198212565e-07 -0.9999999999995 -9.26867307280805e-07 --4.89662593658743e-07 0.999999999999436 9.42843235608704e-07 --0.00018603255153767 -9.20565204593422e-07 0.999999982695521 -0.000186057850679748 9.57376302582163e-07 -0.99999998269078 -0.000185966529185581 9.4956296495799e-07 -0.999999982707774 -4.38496664660628e-07 -0.999999999999508 -8.89823559446053e-07 -0.000185833893773623 9.1872152421149e-07 -0.99999998273246 --0.00017727354767984 -3.80822632307788e-07 0.999999984286972 -4.76978244790639e-07 -0.999999999999847 -2.79240582932941e-07 --0.000122826153445081 2.84679864101293e-06 0.999999992452816 -8.94880168988531e-07 -0.999999999999442 5.62342458782024e-07 --4.82753265081575e-07 0.999999999996399 2.64000920379536e-06 -4.96362094665942e-07 -0.999999999999598 7.46624867282825e-07 --0.00017290552896337 -1.85223452327906e-06 0.999999985050124 -3.74512906655213e-07 -0.999999999999443 -9.86859587432555e-07 --0.000101385313831906 -1.85920675302714e-06 0.999999994858781 --3.87792560744675e-07 0.999999999999559 8.55932005278183e-07 --0.000184615115415908 -8.87510631520921e-07 0.999999982958236 --0.000185227007006118 -1.07398745854616e-06 0.999999982844901 --4.04488846368959e-07 0.999999999999058 1.3118580302775e-06 --4.14961923526126e-07 0.999999999998982 1.36509074952708e-06 -4.91794565931978e-07 0.99999999997869 6.5098367805503e-06 -8.11193747236347e-05 3.60091326236069e-06 -0.99999999670334 -1.92660608753369e-06 0.999999999972378 7.17859359447037e-06 -1.61574011863761e-06 0.999999999965918 8.09645387685258e-06 --0.000184498073784576 -8.88387246470654e-07 0.999999982979836 -5.31689389229473e-07 -0.999999999999796 -3.55044106844848e-07 -0.000182279363632718 1.20510689103038e-06 -0.999999983386391 --4.29792693138529e-07 0.999999999999482 9.229894774512e-07 -1.35189576546266e-07 -0.999999999997583 2.19430363892908e-06 -9.99007370264042e-07 -0.999999999997789 1.85046263237624e-06 -9.45721810847495e-08 0.999999999993455 3.61663677718345e-06 --9.92575609711591e-08 0.999999999994317 3.37001449771037e-06 --0.000151997713029008 -2.85912464234324e-06 0.99999998844426 -8.29821014067833e-07 0.999999999990535 4.27096559916682e-06 -1 9.61384885881614e-15 -3.12573136547161e-15 --1.50794093641592e-06 -0.999999999987827 4.6981538478367e-06 --1.31759164816855e-06 -0.999999999971319 7.45830426514423e-06 -1.0882594559733e-06 0.999999999969593 7.72198063405476e-06 -4.72016459983461e-07 0.999999999970163 7.71040198635128e-06 --2.69962174804447e-07 0.999999999999293 1.15851092705257e-06 --0.000181553577144201 -7.5266553066776e-07 0.999999983518866 --3.50959015893508e-07 0.99999999998837 4.81005766936295e-06 -0.00014918582676461 2.45776682147871e-06 -0.999999988868774 -2.14059863562268e-06 0.999999999982092 5.58878855960034e-06 --0.000184825682794856 -8.78759537613698e-07 0.999999982919347 -0.000124776566523063 2.99905465174885e-06 -0.999999992210907 --1.48859919719611e-07 0.999999999998181 1.9015997253009e-06 --8.49998384872029e-07 -0.999999999993833 3.40746825324601e-06 -0.000131995525853201 -1.5781310602566e-06 -0.999999991287345 --9.30551029710309e-05 -4.16126297958503e-06 0.999999995661716 --1.43467758245687e-06 -0.999999999988519 4.57204511876005e-06 --3.74735246431962e-07 0.999999999999569 8.4977776026603e-07 -2.58409297552502e-07 -0.999999999982643 5.8862144816794e-06 --0.00018529041187524 -8.97897840093493e-07 0.999999982833328 -0.000185596124727451 8.83716899623581e-07 -0.999999982776649 --0.000186050283209108 -9.35724943340359e-07 0.999999982692208 -0.000138392609914983 2.93754916905417e-06 -0.999999990419428 --0.000184988764204081 -8.74420598662455e-07 0.999999982889196 --4.0935697028518e-07 0.999999999999446 9.70062989374838e-07 -3.08945939567449e-07 -0.999999999999405 1.04656153103692e-06 --0.000186002405862718 -9.65315192896409e-07 0.999999982701087 --0.000182712968880662 -1.1445700966409e-06 0.99999998330733 --3.73827230919051e-07 0.999999999999535 8.88470814872305e-07 -0.000184451087740998 9.06932421043325e-07 -0.999999982988487 --3.68625342290041e-07 0.999999999999529 8.98248040365889e-07 --0.999999982981618 -3.75284530456785e-07 -0.000184490169627282 --0.999999982981321 -3.78308804068018e-07 -0.000184491776610901 --3.79846551979779e-07 0.999999999999526 8.96395075466507e-07 --0.000184449808113127 -9.05329765777156e-07 0.999999982988724 --0.999999982981267 -3.76849532743307e-07 -0.000184492067698634 --0.999999982981222 -3.70655101921586e-07 -0.000184492327057835 --3.26377901693732e-07 0.999999999998817 1.50350529816335e-06 --2.32979136132727e-07 0.999999999992768 3.79604223518157e-06 -0.000150753955199823 5.98491136715572e-07 -0.999999988636443 --6.17993272345193e-05 1.62021016933414e-06 0.999999998089109 -2.4373173092453e-05 2.83607504725807e-06 -0.999999999698953 --0.00013405418286101 1.01451751234729e-06 0.999999991014223 -8.83115320128323e-07 0.999999999971173 7.54150184724571e-06 --7.77688189099865e-05 2.79380776328299e-06 0.999999996972103 -0.000120387620729823 -1.11917751151768e-06 -0.999999992752784 -0.000108812239469698 -1.36956184440866e-06 -0.999999994079011 --2.01680030660898e-06 -0.99999999998715 4.65101598797276e-06 --0.000102166332235021 2.22254098171361e-06 0.999999994778551 --4.25881768172172e-07 0.999999999984288 5.58952542280006e-06 -4.3054106113347e-05 4.28825298628793e-06 -0.999999999063978 -6.95152840265347e-07 0.999999999974383 7.12397845133146e-06 -6.26501704441007e-05 2.0753126252546e-06 -0.999999998035325 -5.62740935773424e-07 0.99999999996847 7.92113455577219e-06 -5.89248422539045e-05 -2.9728577794468e-06 -0.999999998259513 --2.19888209489869e-06 -0.99999999998905 4.13091338640608e-06 -3.69094847642743e-07 0.999999999964761 8.38701162980037e-06 --2.64910893574259e-06 -0.999999999992501 2.82480520858863e-06 -6.22984999285726e-07 0.999999999971421 7.53454545647829e-06 -3.52900806019792e-07 -0.999999999996535 2.60892388635685e-06 -1.63407715369607e-06 0.999999999974822 6.90545511818933e-06 -1.43904975221553e-06 0.999999999977619 6.53385392128073e-06 --1.40416531234828e-06 -0.999999999986832 4.93599180569039e-06 --0.000115307778313693 -2.70573644413773e-06 0.999999993348398 -6.90312246289712e-05 2.83414174939204e-07 -0.999999997617305 --0.000184549844267964 -9.51361803479245e-07 0.999999982970225 --5.7488096799919e-05 4.87582566538429e-07 0.999999998347441 -9.35160654313812e-05 3.95501005300473e-06 -0.999999995619552 -1.29498762623843e-06 0.999999999974552 7.0156056472426e-06 --1.40778523239454e-06 -0.999999999989792 4.29357535828671e-06 --1.7522516940945e-06 -0.999999999986892 4.81093773728675e-06 --3.84939167970287e-07 0.999999999999562 8.53306257253577e-07 -7.2395288459441e-05 3.37003075714837e-06 -0.999999997373783 --0.000110123931834166 3.10949636853627e-06 0.999999993931525 --1.52215224676006e-07 -0.999999999997443 2.25648724522132e-06 -2.87023551067365e-06 0.999999999970659 7.10236141792503e-06 -0.000117032794484193 1.08880565740783e-06 -0.99999999315107 -7.38761585007171e-05 -2.31252754206754e-06 -0.999999997268483 -0.000100555197694035 1.5508904785605e-06 -0.999999994943124 --0.000140473149827745 -2.66726195956761e-06 0.99999999013009 -9.75693835174787e-05 -3.08039349121897e-06 -0.999999995235363 -6.87467790520876e-07 0.999999999986874 5.07736477326427e-06 --1.76257619264604e-06 -0.999999999987086 4.76669859887209e-06 --4.13406596519492e-07 -0.999999999992528 3.84355702875049e-06 -2.44518304074926e-05 -2.64975200246997e-06 -0.999999999697543 --3.50010970034756e-07 -0.999999999996209 2.7313089251535e-06 -1 -7.86465346720034e-15 7.37017202601017e-15 --6.76290043283527e-07 0.999999999971123 7.56948832519845e-06 --0.00014466220438946 8.88193685730649e-07 0.999999989536029 -4.83044094107647e-07 -0.999999999999563 -8.00049879235452e-07 -3.16008907959751e-08 0.999999999988541 4.78711101548269e-06 --5.75425200994772e-07 0.999999999996975 2.39136031839817e-06 --6.07312446695271e-05 -2.62103746650552e-06 0.999999998152423 -9.72907828418273e-07 0.999999999979008 6.40606341252217e-06 --7.34573749134595e-05 3.23461365543792e-08 0.999999997302007 -0.000153710029527037 8.95277571428632e-08 -0.99999998818661 --2.91670904669456e-05 -1.94154346021593e-06 0.999999999572756 -4.23927499230031e-05 -5.40513932397143e-06 -0.99999999908682 --4.31307911278669e-05 3.05778605734918e-07 0.999999999069821 --2.50888322751572e-05 -4.72461084350091e-07 0.999999999685164 --0.000179694769508028 -4.83693583694743e-07 0.999999983854778 -6.05018864922324e-05 3.71004701183166e-06 -0.999999998162879 --0.000107223047052797 -4.09659979691784e-06 0.999999994243218 --0.00013770164971371 -1.07072780904572e-06 0.999999990518555 --6.04951249065998e-05 -1.11703476562214e-06 0.999999998169546 --1.34016196580209e-06 -0.999999999978344 6.4433660841838e-06 -1.13583997230625e-07 -0.999999999982364 5.93791571073016e-06 -6.84994394693674e-07 0.999999999975082 7.02610003354745e-06 --9.46679329931682e-07 -0.999999999982566 5.82856567359162e-06 -1 -1.42678532204588e-15 8.37737089022064e-15 -8.7202237554075e-05 -2.80306679441201e-06 -0.999999996193956 --1.07476356345329e-06 -0.999999999990236 4.2862695479965e-06 -8.47390739793928e-07 -0.999999999981836 5.96742048563896e-06 --9.15562274023809e-05 2.30120329721116e-06 0.999999995806081 -0.000183666789050946 1.09192868945522e-06 -0.999999983132659 --1.36169189412691e-07 -0.999999999984307 5.60077833370774e-06 --8.13176397686893e-07 -0.99999999997434 7.11758384559205e-06 -1.79290905502554e-06 0.999999999972729 7.16435897863369e-06 -0.000160878213743662 1.84599861397085e-07 -0.999999987059083 --0.000184452537437502 -9.12736192068676e-07 0.999999982988214 --0.000185819994591248 -8.27763155682344e-07 0.999999982735122 - - -NormalAtVertices -260 -7 1 -8 2 -19 3 -20 4 -22 5 -23 6 -29 7 -30 8 -36 9 -37 10 -41 11 -42 12 -47 13 -48 14 -51 15 -52 16 -59 17 -60 18 -62 19 -63 20 -70 21 -71 22 -73 23 -74 24 -82 25 -83 26 -84 27 -85 28 -93 29 -94 30 -95 31 -96 32 -104 33 -105 34 -106 35 -107 36 -115 37 -116 38 -117 39 -118 40 -127 41 -128 42 -129 43 -130 44 -138 45 -139 46 -141 47 -142 48 -149 49 -150 50 -152 51 -153 52 -162 53 -163 54 -164 55 -165 56 -173 57 -174 58 -175 59 -176 60 -183 61 -184 62 -185 63 -186 64 -194 65 -195 66 -196 67 -197 68 -205 69 -206 70 -207 71 -208 72 -237 73 -254 74 -270 75 -271 76 -272 77 -273 78 -277 79 -279 80 -280 81 -281 82 -282 83 -283 84 -284 85 -285 86 -286 87 -287 88 -288 89 -289 90 -290 91 -291 92 -304 93 -306 94 -308 95 -310 96 -312 97 -320 98 -323 99 -325 100 -326 101 -327 102 -330 103 -331 104 -332 105 -334 106 -337 107 -339 108 -341 109 -342 110 -343 111 -349 112 -350 113 -352 114 -354 115 -356 116 -357 117 -358 118 -366 119 -368 120 -370 121 -371 122 -378 123 -380 124 -381 125 -382 126 -390 127 -392 128 -395 129 -399 130 -406 131 -408 132 -409 133 -412 134 -415 135 -417 136 -418 137 -419 138 -420 139 -421 140 -424 141 -425 142 -429 143 -431 144 -432 145 -433 146 -434 147 -436 148 -443 149 -447 150 -448 151 -449 152 -451 153 -455 154 -462 155 -464 156 -465 157 -469 158 -471 159 -473 160 -475 161 -476 162 -480 163 -482 164 -485 165 -490 166 -493 167 -504 168 -505 169 -506 170 -507 171 -508 172 -509 173 -510 174 -512 175 -514 176 -516 177 -521 178 -523 179 -530 180 -534 181 -535 182 -536 183 -537 184 -538 185 -541 186 -542 187 -544 188 -546 189 -547 190 -549 191 -550 192 -551 193 -552 194 -554 195 -555 196 -556 197 -557 198 -561 199 -564 200 -565 201 -566 202 -572 203 -574 204 -580 205 -585 206 -587 207 -591 208 -593 209 -597 210 -599 211 -604 212 -607 213 -608 214 -612 215 -614 216 -617 217 -618 218 -623 219 -624 220 -628 221 -629 222 -631 223 -637 224 -644 225 -647 226 -650 227 -655 228 -658 229 -660 230 -664 231 -667 232 -672 233 -673 234 -678 235 -688 236 -689 237 -692 238 -696 239 -697 240 -698 241 -699 242 -702 243 -703 244 -704 245 -706 246 -711 247 -713 248 -715 249 -717 250 -719 251 -720 252 -721 253 -723 254 -724 255 -725 256 -728 257 -729 258 -733 259 -738 260 - - -Tangents -109 -0 -0.999999999999979 -2.03740190471593e-07 -0.999999999370852 2.6120617364071e-06 3.53761768586268e-05 -0 -2.49873052064459e-06 0.999999999996878 -0.999999997680203 -1.47223512499522e-06 6.80986577874983e-05 -0 0.999999999999961 -2.79327381788766e-07 -0.999999999340191 -3.3962148400064e-06 3.61674477755079e-05 -0.999999999445807 -3.3736126267936e-06 3.31210764219678e-05 --0 2.16273055180652e-06 0.999999999997661 -0.999999997746752 -6.6014507605062e-07 6.71271895803217e-05 -0.999999998142356 -1.87439178231037e-06 6.09243340686901e-05 -0.999999999081956 -2.15527017905465e-08 4.28495826694188e-05 -0.999999994877966 -9.79230992277999e-07 0.000101208251283811 -0.999999997989805 -1.80112107111696e-06 6.3380967220019e-05 --0.999999994675542 1.13294239488265e-06 -0.000103187370116226 --0.999999995585518 3.091836531715e-07 -9.3962059604451e-05 -0.999999993089317 -1.65103376643532e-06 0.000117552715403644 --0.99999999506779 1.9296185116737e-06 -9.93010434484281e-05 --0.999999992960925 -7.54059922717636e-08 -0.000118651354520646 -0.999999993057477 -5.49820916482888e-07 0.000117833538402364 -0.999999993478007 -1.65748850908112e-06 0.000114198240413017 --0.999999991385977 4.10530242623967e-06 -0.000131191438461125 --0.999999991062303 -7.88565548631237e-07 -0.000133696569107851 --0.999999990431262 -6.20604135904622e-07 -0.00013833687751803 -0.999999990345236 -1.00542173398697e-06 0.000138955093359046 -0.99999998830768 -1.57936106712602e-07 0.00015292028728991 --0.999999987781487 -1.78029788652581e-06 -0.00015631332554965 -0.999999988548103 3.81069196764413e-07 0.000151339516640273 -0.999999988500516 -8.65465810572414e-07 0.00015165163993186 --0.999999986835958 1.04293124925359e-07 -0.000162259278151113 -0.999999986652975 8.12063226458834e-07 0.000163381122165114 -0.999999986599566 1.10810655371631e-06 0.000163705958249699 --0.999999986734442 2.03930462277313e-07 -0.000162883619419735 -0.999999985421059 3.26679740871966e-08 0.000170756790570068 --0.99999998539421 -8.33880352432693e-07 -0.000170911920291862 -0.999999985157244 6.62260438436826e-07 0.00017229357086576 -0.999999985347583 9.91895386311711e-08 0.000171186517773418 --0.999999984339233 -2.69150657857906e-07 -0.000176978701026044 -0.999999984224925 9.25026296402357e-07 0.000177621212816806 -0.999999984149469 1.19836831613994e-06 0.000178043888342097 -0.999999984238587 2.69960777420415e-07 0.000177546480662173 --0.999999983548487 -1.30408676929628e-07 -0.000181391865668414 -0.999999983553663 6.56122691029008e-07 0.000181362188755556 --0.999999983470155 -6.51498781652711e-07 -0.000181822072290427 --0.999999983526729 -1.49279224313946e-07 -0.000181511762461006 -0.999999982993839 3.68217393015399e-07 0.000184423929648665 -0.999999983055822 6.20854054436726e-07 0.000184086856898505 --0.999999983003959 -5.78647145475987e-07 -0.00018436850641689 -0.999999983051916 2.57123605046528e-07 0.000184108939002519 --0.999999982783097 -2.28360366456148e-07 -0.000185563341356985 --0.99999998281688 -6.30995766007973e-07 -0.000185380264773526 -0.999999982782262 6.2331386205617e-07 0.000185566936341794 --0.999999982794348 -2.37765082074531e-07 -0.000185502686021846 --0.999999982696759 -3.27916739851497e-07 -0.00018602788712439 -0.999999982686973 4.97749942833715e-07 0.000186080106187882 -0.999999982686098 5.05318665964873e-07 0.000186084788587512 -0.99999998269717 3.3033247705416e-07 0.000186025670697263 -0.99999998271666 3.68369593522787e-07 0.000185920801830461 --0.999999982713983 -4.89745218579694e-07 -0.000185934916947943 --0.999999982702736 -4.82212288318357e-07 -0.000185995417170162 --0.99999998271061 -3.67981619443718e-07 -0.000185953338833862 -0.999999982784598 3.77226786738477e-07 0.000185555010044285 --0.999999982775364 -4.25284561365185e-07 -0.00018560466395998 -0.999999982771797 4.22792669509264e-07 0.000185623884168459 -0.999999982772691 3.73044054854467e-07 0.0001856191745327 --0.999999982858168 -3.73572544752027e-07 -0.000185158104284139 --0.999999982861285 -3.71983832597884e-07 -0.000185141272325914 -0.999999982854409 3.88528638527369e-07 0.000185178373811632 --0.99999998284873 -3.79363031654826e-07 -0.000185209062207874 -0.999999982928501 3.88806097052603e-07 0.000184777830861846 -0.99999998292397 3.70807811037877e-07 0.000184802390405468 -0.999999982920466 3.68329951351166e-07 0.000184821354246886 -0.999999982922954 3.82847787612186e-07 0.000184807862781359 --0.999999982973047 -3.95410973374865e-07 -0.000184536580494342 --0.9999999829693 -3.65182178721787e-07 -0.000184556946668237 --0.999999982965686 -3.50469954104007e-07 -0.000184576555758976 --0.9999999829697 -3.9315254214302e-07 -0.000184554721914107 --0.999999982988947 -3.91380536389497e-07 -0.000184450405079989 --0.999999982987952 -3.63903507788924e-07 -0.000184455858632986 --0.999999982988008 -3.63808405013174e-07 -0.000184455555068008 --0.999999982986984 -3.85410877090796e-07 -0.000184461058759707 -3.74724455839767e-07 -0.999999999999515 -9.10549137004007e-07 --0.000184493984504458 -8.97388014178855e-07 0.999999982980582 -3.76485421157987e-07 -0.999999999999515 -9.10001743055239e-07 --0.000184496332583864 -9.21171007898068e-07 0.999999982980127 --0.999999999688317 -6.71184291112188e-06 -2.40482272882974e-05 --0 1 2.03740200494103e-09 -0 1 -3.06255350093847e-20 -0.99999999968401 -4.5030010668314e-06 2.4732621786689e-05 -0 -1 -2.40200015058738e-19 --0.999999999776563 -6.12010653130631e-06 -2.02340752856349e-05 -0 -3.82784776779229e-18 1 -0.999999999741185 -7.08333422684922e-06 2.16207366290498e-05 -0 -1 -1.71484467196197e-19 -0 -3.54530435651551e-08 1 -3.19747186461287e-15 1.0263798078677e-07 -0.999999999999995 -0 -2.67003771808252e-08 -1 --0.999999982690662 -5.83379884299696e-07 -0.000186060032880952 --0.999999989621591 7.46386030496089e-07 -0.000144070333825661 --0.999999989407726 2.73692770645738e-07 -0.000145548867774508 -0.999999992132993 -2.06124309403013e-06 0.000125418363211047 --0.999999994532123 8.18119853315365e-07 -0.000104570955253212 --0.999999996703058 2.26974672317118e-06 -8.11710120577534e-05 --0.999999991555136 -2.99817310767551e-07 -0.000129960141089432 --0.999999996430108 1.91453208191472e-07 -8.44970274209808e-05 -0.99999999643202 -2.74095104077242e-06 8.44301361251177e-05 --0.999999996684764 -1.89640711934518e-07 -8.14274867012333e-05 -0.999999998725789 3.34675371807766e-07 5.0480783324656e-05 -0.999999998536022 -1.42979668484834e-06 5.40917008210548e-05 -0.999999998911928 -3.22029735159844e-06 4.65378749203669e-05 - - -TangentAtVertices -109 -2 1 -3 2 -4 3 -12 4 -14 5 -15 6 -16 7 -17 8 -25 9 -26 10 -27 11 -28 12 -31 13 -34 14 -35 15 -38 16 -40 17 -45 18 -46 19 -49 20 -50 21 -55 22 -56 23 -61 24 -64 25 -68 26 -69 27 -72 28 -75 29 -78 30 -79 31 -81 32 -86 33 -90 34 -91 35 -92 36 -97 37 -101 38 -102 39 -103 40 -109 41 -110 42 -111 43 -113 44 -119 45 -123 46 -124 47 -126 48 -131 49 -135 50 -136 51 -137 52 -143 53 -145 54 -146 55 -148 56 -155 57 -158 58 -159 59 -160 60 -166 61 -170 62 -171 63 -172 64 -178 65 -179 66 -180 67 -181 68 -187 69 -191 70 -192 71 -193 72 -200 73 -202 74 -203 75 -204 76 -210 77 -211 78 -212 79 -213 80 -218 81 -219 82 -222 83 -223 84 -274 85 -275 86 -276 87 -278 88 -292 89 -293 90 -294 91 -295 92 -296 93 -297 94 -298 95 -299 96 -340 97 -423 98 -438 99 -474 100 -487 101 -502 102 -532 103 -548 104 -573 105 -586 106 -603 107 -646 108 -727 109 - - -Triangles -750 -368 23 462 7 -475 155 304 7 -207 213 320 7 -162 173 323 7 -224 326 213 7 -164 152 160 7 -213 208 332 7 -599 330 166 7 -720 281 704 7 -224 213 332 7 -341 340 339 7 -158 170 162 7 -158 343 170 7 -224 512 222 7 -153 165 160 7 -356 664 97 7 -330 178 166 7 -152 164 341 7 -337 163 159 7 -341 343 158 7 -395 573 12 7 -350 107 354 7 -145 149 138 7 -306 20 597 7 -208 204 197 7 -49 541 40 7 -49 40 424 7 -103 96 107 7 -107 96 354 7 -96 85 485 7 -448 614 51 7 -62 436 476 7 -354 357 102 7 -358 82 86 7 -103 106 95 7 -381 380 119 7 -197 193 186 7 -200 371 187 7 -93 105 349 7 -195 192 184 7 -334 340 158 7 -341 158 340 7 -197 366 192 7 -193 196 185 7 -339 145 141 7 -370 206 200 7 -392 564 37 7 -523 436 62 7 -69 412 561 7 -448 51 476 7 -149 340 334 7 -612 565 443 7 -139 378 131 7 -138 432 380 7 -334 158 162 7 -138 127 135 7 -438 434 660 7 -273 587 390 7 -27 689 280 7 -623 702 310 7 -127 380 381 7 -552 689 27 7 -72 608 74 7 -37 672 382 7 -323 166 155 7 -129 117 126 7 -139 131 143 7 -115 123 127 7 -118 130 126 7 -116 128 124 7 -184 180 174 7 -124 406 350 7 -406 130 118 7 -115 104 110 7 -433 697 105 7 -110 106 408 7 -409 323 155 7 -85 81 74 7 -699 28 38 7 -71 83 75 7 -506 211 220 7 -505 220 211 7 -70 82 79 7 -412 69 79 7 -70 79 69 7 -618 30 624 7 -282 704 281 7 -85 412 415 7 -417 420 60 7 -418 75 64 7 -419 75 70 7 -52 593 719 7 -415 79 91 7 -382 45 546 7 -644 451 52 7 -729 84 73 7 -729 678 81 7 -530 727 692 7 -432 143 131 7 -129 141 135 7 -73 68 436 7 -64 75 419 7 -725 469 713 7 -25 604 548 7 -25 548 431 7 -382 47 565 7 -94 104 664 7 -380 131 119 7 -378 119 131 7 -173 183 330 7 -465 370 187 7 -617 552 31 7 -312 306 554 7 -63 561 608 7 -447 184 480 7 -298 628 288 7 -30 273 574 7 -325 155 166 7 -148 142 153 7 -186 181 176 7 -356 86 83 7 -40 629 542 7 -183 194 465 7 -357 91 102 7 -83 90 94 7 -124 350 111 7 -95 90 84 7 -471 166 178 7 -176 165 171 7 -23 537 673 7 -173 179 183 7 -40 624 717 7 -471 178 480 7 -432 131 380 7 -136 142 130 7 -433 493 116 7 -343 164 473 7 -174 325 471 7 -323 599 166 7 -207 196 204 7 -354 96 357 7 -170 327 179 7 -288 285 650 7 -482 155 143 7 -337 150 475 7 -26 727 530 7 -603 650 555 7 -14 296 647 7 -292 14 284 7 -292 637 14 7 -448 476 55 7 -490 475 150 7 -299 17 421 7 -115 110 123 7 -408 123 110 7 -194 202 206 7 -145 138 135 7 -196 207 202 7 -698 550 604 7 -142 137 130 7 -117 106 113 7 -603 237 3 7 -280 279 637 7 -628 285 288 7 -535 532 352 7 -487 566 35 7 -506 219 504 7 -211 207 320 7 -320 326 222 7 -175 164 172 7 -219 217 509 7 -506 504 211 7 -505 320 222 7 -512 223 514 7 -159 146 337 7 -507 220 222 7 -505 222 220 7 -219 508 217 7 -509 217 210 7 -217 218 510 7 -504 210 206 7 -631 719 42 7 -221 514 223 7 -275 1 274 7 -418 64 417 7 -116 124 111 7 -115 516 104 7 -139 128 378 7 -281 294 17 7 -538 614 541 7 -185 179 327 7 -637 279 534 7 -149 482 138 7 -547 19 550 7 -332 212 223 7 -289 277 696 7 -516 119 109 7 -93 91 82 7 -349 105 697 7 -113 106 103 7 -162 170 173 7 -113 103 107 7 -123 129 135 7 -123 135 127 7 -14 534 296 7 -349 697 102 7 -204 193 197 7 -204 196 193 7 -180 176 171 7 -493 105 109 7 -180 171 174 7 -160 148 153 7 -160 152 148 7 -81 678 72 7 -81 72 74 7 -566 29 272 7 -78 84 90 7 -78 90 83 7 -136 130 124 7 -136 124 128 7 -72 62 61 7 -72 644 608 7 -181 172 176 7 -181 175 172 7 -299 556 282 7 -429 612 38 7 -304 163 337 7 -137 126 130 7 -137 129 126 7 -191 196 202 7 -191 202 194 7 -101 106 110 7 -101 110 104 7 -193 181 186 7 -193 185 181 7 -103 95 92 7 -148 152 141 7 -103 92 96 7 -487 544 607 7 -171 165 159 7 -171 159 163 7 -45 448 55 7 -45 55 546 7 -702 535 48 7 -148 137 142 7 -148 141 137 7 -179 185 191 7 -179 191 183 7 -90 95 101 7 -90 101 94 7 -172 160 165 7 -172 164 160 7 -92 84 81 7 -354 102 111 7 -697 111 102 7 -92 81 85 7 -68 73 78 7 -184 174 471 7 -68 78 71 7 -126 113 118 7 -126 117 113 7 -330 183 465 7 -213 204 208 7 -213 207 204 7 -212 208 203 7 -212 203 205 7 -202 207 211 7 -143 475 490 7 -202 211 206 7 -75 83 86 7 -75 86 82 7 -210 510 399 7 -210 200 206 7 -647 296 291 7 -24 294 293 7 -24 292 294 7 -10 297 296 7 -10 295 297 7 -70 75 82 7 -299 276 11 7 -299 11 278 7 -733 205 510 7 -382 546 47 7 -667 237 603 7 -644 63 608 7 -178 465 187 7 -178 187 480 7 -145 135 141 7 -415 412 79 7 -153 142 658 7 -339 340 145 7 -297 286 628 7 -719 464 42 7 -278 11 276 7 -277 278 276 7 -143 155 475 7 -224 222 326 7 -320 213 326 7 -512 514 507 7 -692 16 277 7 -282 281 17 7 -580 119 378 7 -119 580 493 7 -370 200 187 7 -194 206 370 7 -696 277 276 7 -24 293 292 7 -292 293 280 7 -293 294 281 7 -727 312 554 7 -514 508 507 7 -294 292 284 7 -10 296 295 7 -628 286 285 7 -295 296 287 7 -296 297 291 7 -297 295 286 7 -487 35 544 7 -298 274 1 7 -298 288 274 7 -298 1 275 7 -290 298 275 7 -282 17 299 7 -667 703 237 7 -325 166 471 7 -308 2 276 7 -31 27 425 7 -280 637 292 7 -72 678 62 7 -290 715 298 7 -451 593 52 7 -49 593 474 7 -546 660 47 7 -532 46 352 7 -178 330 465 7 -31 425 725 7 -37 382 429 7 -323 173 599 7 -358 97 93 7 -672 45 382 7 -200 399 371 7 -176 172 165 7 -717 30 617 7 -221 733 218 7 -136 658 142 7 -186 331 366 7 -325 304 155 7 -310 38 50 7 -612 50 38 7 -185 175 181 7 -184 192 180 7 -331 180 192 7 -150 139 490 7 -537 530 673 7 -150 337 146 7 -72 61 644 7 -159 342 146 7 -678 729 73 7 -254 275 274 7 -554 597 556 7 -152 341 339 7 -557 431 551 7 -599 173 330 7 -475 304 337 7 -197 192 203 7 -195 203 192 7 -462 271 573 7 -341 164 343 7 -197 186 366 7 -544 35 721 7 -502 713 629 7 -30 574 617 7 -35 272 586 7 -211 320 505 7 -124 130 406 7 -406 118 350 7 -162 323 409 7 -283 290 308 7 -71 78 83 7 -702 48 310 7 -71 75 418 7 -96 92 85 7 -516 449 104 7 -534 279 287 7 -356 94 664 7 -433 105 493 7 -183 191 194 7 -392 536 728 7 -706 306 312 7 -184 471 480 7 -224 332 223 7 -224 223 512 7 -623 310 50 7 -436 68 438 7 -434 438 68 7 -425 720 704 7 -63 52 56 7 -561 56 69 7 -141 129 137 7 -15 287 547 7 -371 447 187 7 -138 380 127 7 -541 41 618 7 -93 349 91 7 -352 46 607 7 -95 106 101 7 -449 109 97 7 -392 37 536 7 -85 74 412 7 -667 271 703 7 -40 502 629 7 -40 717 502 7 -15 547 646 7 -433 111 697 7 -36 607 544 7 -673 530 585 7 -672 37 564 7 -350 354 111 7 -395 270 392 7 -655 59 70 7 -423 623 50 7 -420 423 50 7 -447 195 184 7 -698 604 25 7 -27 720 425 7 -443 420 50 7 -185 327 175 7 -443 50 612 7 -47 60 420 7 -116 493 580 7 -51 614 538 7 -566 464 542 7 -349 102 91 7 -580 128 116 7 -544 368 36 7 -117 129 723 7 -724 312 26 7 -593 424 719 7 -482 143 432 7 -574 552 617 7 -45 41 448 7 -502 717 617 7 -631 42 46 7 -358 86 97 7 -356 97 86 7 -433 116 111 7 -118 107 350 7 -521 417 60 7 -490 139 143 7 -474 593 451 7 -59 623 419 7 -419 70 59 7 -298 4 628 7 -47 420 443 7 -508 218 217 7 -95 84 92 7 -205 203 195 7 -572 38 310 7 -61 474 451 7 -61 455 474 7 -113 107 118 7 -555 270 395 7 -3 288 650 7 -208 197 203 7 -421 283 308 7 -434 521 60 7 -521 418 417 7 -71 418 521 7 -586 724 26 7 -586 26 537 7 -647 291 283 7 -455 61 62 7 -159 165 342 7 -409 155 482 7 -170 473 327 7 -664 104 449 7 -51 455 62 7 -270 551 22 7 -485 91 357 7 -650 603 3 7 -516 109 449 7 -699 462 28 7 -516 381 119 7 -41 587 618 7 -720 293 281 7 -541 618 624 7 -40 541 624 7 -297 628 4 7 -473 164 175 7 -289 254 688 7 -69 655 70 7 -618 587 30 7 -64 423 417 7 -115 381 516 7 -115 127 381 7 -554 556 16 7 -548 390 587 7 -48 535 352 7 -325 174 163 7 -15 591 286 7 -56 532 535 7 -368 462 699 7 -728 536 28 7 -514 218 508 7 -185 196 191 7 -689 19 279 7 -719 424 464 7 -49 424 593 7 -47 660 60 7 -84 78 73 7 -222 512 507 7 -504 206 211 7 -219 509 504 7 -128 139 738 7 -604 390 548 7 -85 415 485 7 -36 368 572 7 -566 487 42 7 -278 556 299 7 -237 703 7 7 -2 308 290 7 -476 438 55 7 -660 55 438 7 -434 68 71 7 -688 274 3 7 -288 3 274 7 -646 547 698 7 -8 551 270 7 -342 153 658 7 -287 279 547 7 -149 409 482 7 -63 644 52 7 -465 194 370 7 -572 699 38 7 -31 725 713 7 -436 438 476 7 -482 432 138 7 -493 109 119 7 -733 510 218 7 -587 273 30 7 -548 34 549 7 -566 42 464 7 -105 97 109 7 -409 334 162 7 -408 106 117 7 -542 629 566 7 -509 210 504 7 -217 510 210 7 -650 8 555 7 -74 608 412 7 -31 552 27 7 -532 631 46 7 -210 399 200 7 -469 29 713 7 -688 254 274 7 -41 614 448 7 -629 713 29 7 -536 429 38 7 -48 352 36 7 -35 586 721 7 -73 523 678 7 -550 19 574 7 -15 286 295 7 -287 15 295 7 -566 272 35 7 -46 487 607 7 -289 692 277 7 -646 25 557 7 -285 711 8 7 -655 69 56 7 -285 8 650 7 -342 165 153 7 -507 508 219 7 -28 573 728 7 -128 580 378 7 -572 48 36 7 -597 704 282 7 -289 688 237 7 -536 38 28 7 -510 205 399 7 -646 698 25 7 -176 180 331 7 -22 551 431 7 -96 485 357 7 -270 555 8 7 -26 312 727 7 -412 608 561 7 -382 565 429 7 -552 19 689 7 -591 551 711 7 -447 480 187 7 -36 352 607 7 -37 429 536 7 -22 392 270 7 -221 212 733 7 -136 128 738 7 -208 212 332 7 -423 420 417 7 -550 273 604 7 -150 146 738 7 -624 30 717 7 -711 551 8 7 -48 572 310 7 -52 631 532 7 -368 699 572 7 -94 101 104 7 -421 284 283 7 -366 331 192 7 -283 291 715 7 -283 715 290 7 -291 297 4 7 -56 52 532 7 -298 715 4 7 -93 97 105 7 -696 2 254 7 -219 220 507 7 -506 220 219 7 -2 290 275 7 -173 170 179 7 -473 175 327 7 -343 473 170 7 -59 702 623 7 -7 692 289 7 -7 289 237 7 -629 29 566 7 -557 25 431 7 -356 83 94 7 -573 271 12 7 -289 696 254 7 -548 587 34 7 -464 424 542 7 -22 564 392 7 -52 719 631 7 -277 16 278 7 -646 557 591 7 -474 455 538 7 -502 31 713 7 -205 195 371 7 -703 585 7 7 -399 205 371 7 -299 421 308 7 -574 19 552 7 -727 554 16 7 -721 586 537 7 -538 541 49 7 -28 462 573 7 -554 306 597 7 -703 673 585 7 -47 443 565 7 -425 704 20 7 -696 276 2 7 -644 61 451 7 -689 279 280 7 -549 34 564 7 -14 647 284 7 -342 658 146 7 -62 476 51 7 -655 56 535 7 -434 60 660 7 -546 55 660 7 -502 617 31 7 -41 34 587 7 -534 287 296 7 -186 176 331 7 -371 195 447 7 -284 647 283 7 -82 91 79 7 -63 56 561 7 -368 721 23 7 -45 672 34 7 -485 415 91 7 -623 423 419 7 -308 276 299 7 -469 20 306 7 -149 334 409 7 -2 275 254 7 -20 704 597 7 -557 551 591 7 -117 723 408 7 -294 284 421 7 -556 278 16 7 -548 549 431 7 -136 146 658 7 -136 738 146 7 -291 4 715 7 -721 537 23 7 -45 34 41 7 -702 655 535 7 -59 655 702 7 -273 550 574 7 -449 97 664 7 -591 711 286 7 -271 673 703 7 -538 455 51 7 -152 339 141 7 -358 93 82 7 -29 706 272 7 -530 537 26 7 -174 171 163 7 -23 673 271 7 -614 41 541 7 -672 564 34 7 -724 272 706 7 -27 293 720 7 -27 280 293 7 -150 738 139 7 -565 612 429 7 -285 286 711 7 -368 544 721 7 -163 304 325 7 -549 22 431 7 -81 84 729 7 -71 521 434 7 -728 573 392 7 -19 547 279 7 -585 692 7 7 -725 425 20 7 -586 272 724 7 -667 12 271 7 -419 423 64 7 -29 469 706 7 -145 340 149 7 -221 223 212 7 -727 16 692 7 -555 395 12 7 -723 123 408 7 -723 129 123 7 -549 564 22 7 -392 573 395 7 -469 306 706 7 -212 205 733 7 -49 474 538 7 -15 646 591 7 -530 692 585 7 -603 555 12 7 -603 12 667 7 -706 312 724 7 -469 725 20 7 -534 14 637 7 -294 421 17 7 -237 688 3 7 -462 23 271 7 -221 218 514 7 -597 282 556 7 -46 42 487 7 -550 698 547 7 -40 542 424 7 -73 436 523 7 -678 523 62 7 -604 273 390 7 - - -Edges -121 -203 212 0 -160 172 0 -1 274 0 -119 131 0 -1 275 0 -3 274 0 -78 90 0 -2 275 0 -68 438 0 -2 276 0 -79 91 0 -38 50 0 -40 49 0 -81 92 0 -123 135 0 -210 217 0 -11 276 0 -124 136 0 -166 178 0 -11 278 0 -126 137 0 -211 220 0 -170 179 0 -212 221 0 -217 218 0 -86 97 0 -45 55 0 -46 532 0 -171 180 0 -217 219 0 -172 181 0 -25 548 0 -213 224 0 -218 221 0 -220 222 0 -131 143 0 -90 101 0 -56 532 0 -221 223 0 -145 340 0 -91 102 0 -34 548 0 -222 224 0 -223 224 0 -92 103 0 -1 298 0 -135 145 0 -4 297 0 -178 187 0 -4 298 0 -49 474 0 -136 146 0 -14 292 0 -10 295 0 -10 296 0 -137 148 0 -158 340 0 -15 295 0 -35 487 0 -17 294 0 -14 296 0 -11 299 0 -180 192 0 -97 109 0 -24 292 0 -12 573 0 -181 193 0 -24 293 0 -56 69 0 -24 294 0 -17 299 0 -27 293 0 -101 110 0 -46 487 0 -102 111 0 -143 155 0 -15 646 0 -103 113 0 -61 72 0 -31 502 0 -28 573 0 -50 423 0 -187 200 0 -146 159 0 -64 75 0 -27 31 0 -25 646 0 -148 160 0 -40 502 0 -191 202 0 -109 119 0 -192 203 0 -68 78 0 -193 204 0 -64 423 0 -69 79 0 -16 727 0 -28 38 0 -110 123 0 -26 586 0 -111 124 0 -72 81 0 -3 603 0 -155 166 0 -113 126 0 -26 727 0 -35 586 0 -55 438 0 -200 210 0 -12 603 0 -75 86 0 -158 170 0 -34 45 0 -202 211 0 -159 171 0 -179 191 0 -204 213 0 -10 297 0 -61 474 0 -219 220 0 -16 278 0 - - -Ridges -121 -1 -2 -3 -4 -5 -6 -7 -8 -9 -10 -11 -12 -13 -14 -15 -16 -17 -18 -19 -20 -21 -22 -23 -24 -25 -26 -27 -28 -29 -30 -31 -32 -33 -34 -35 -36 -37 -38 -39 -40 -41 -42 -43 -44 -45 -46 -47 -48 -49 -50 -51 -52 -53 -54 -55 -56 -57 -58 -59 -60 -61 -62 -63 -64 -65 -66 -67 -68 -69 -70 -71 -72 -73 -74 -75 -76 -77 -78 -79 -80 -81 -82 -83 -84 -85 -86 -87 -88 -89 -90 -91 -92 -93 -94 -95 -96 -97 -98 -99 -100 -101 -102 -103 -104 -105 -106 -107 -108 -109 -110 -111 -112 -113 -114 -115 -116 -117 -118 -119 -120 -121 - - -End diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_result.sol b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_result.sol new file mode 100644 index 000000000000..be859501e76b --- /dev/null +++ b/applications/MeshingApplication/tests/mmg_lagrangian_test/beam3D_test_result.sol @@ -0,0 +1,236 @@ +MeshVersionFormatted 2 + + +Dimension 3 + + +SolAtVertices +224 +1 3 +7.79635201322104 0 7.79635201322104 0 0 7.79635201322104 +11.9367019058822 0 11.9367019058822 0 0 11.9367019058822 +12.8413469391166 0 12.8413469391166 0 0 12.8413469391166 +14.1206768856751 0 14.1206768856751 0 0 14.1206768856751 +14.7336172739325 0 14.7336172739325 0 0 14.7336172739325 +15.7609199459136 0 15.7609199459136 0 0 15.7609199459136 +17.5587728003798 0 17.5587728003798 0 0 17.5587728003798 +16.8928554496856 0 16.8928554496856 0 0 16.8928554496856 +16.3116617503429 0 16.3116617503429 0 0 16.3116617503429 +8.61598653922064 0 8.61598653922064 0 0 8.61598653922064 +7.43936336486709 0 7.43936336486709 0 0 7.43936336486709 +18.1047640421061 0 18.1047640421061 0 0 18.1047640421061 +14.456116775361 0 14.456116775361 0 0 14.456116775361 +14.8571379302681 0 14.8571379302681 0 0 14.8571379302681 +13.1905974807017 0 13.1905974807017 0 0 13.1905974807017 +13.9464491351685 0 13.9464491351685 0 0 13.9464491351685 +10.7321810748853 0 10.7321810748853 0 0 10.7321810748853 +15.9985931689263 0 15.9985931689263 0 0 15.9985931689263 +16.4244340616111 0 16.4244340616111 0 0 16.4244340616111 +16.8860979663096 0 16.8860979663096 0 0 16.8860979663096 +17.0318280829075 0 17.0318280829075 0 0 17.0318280829075 +15.6610704601344 0 15.6610704601344 0 0 15.6610704601344 +15.2697419372011 0 15.2697419372011 0 0 15.2697419372011 +10.2349843205399 0 10.2349843205399 0 0 10.2349843205399 +18.2872454623204 0 18.2872454623204 0 0 18.2872454623204 +18.698983432437 0 18.698983432437 0 0 18.698983432437 +14.4156074380306 0 14.4156074380306 0 0 14.4156074380306 +14.1182381117118 0 14.1182381117118 0 0 14.1182381117118 +16.3957340554801 0 16.3957340554801 0 0 16.3957340554801 +15.7899081466393 0 15.7899081466393 0 0 15.7899081466393 +18.2515298677482 0 18.2515298677482 0 0 18.2515298677482 +13.2177434511616 0 13.2177434511616 0 0 13.2177434511616 +13.7919714941956 0 13.7919714941956 0 0 13.7919714941956 +12.9001950760974 0 12.9001950760974 0 0 12.9001950760974 +13.2710158074754 0 13.2710158074754 0 0 13.2710158074754 +13.4166025019234 0 13.4166025019234 0 0 13.4166025019234 +12.9193558673758 0 12.9193558673758 0 0 12.9193558673758 +12.1677981915316 0 12.1677981915316 0 0 12.1677981915316 +12.4179965332223 0 12.4179965332223 0 0 12.4179965332223 +13.3531262413933 0 13.3531262413933 0 0 13.3531262413933 +12.2634941547038 0 12.2634941547038 0 0 12.2634941547038 +14.6335729375139 0 14.6335729375139 0 0 14.6335729375139 +12.5357515968218 0 12.5357515968218 0 0 12.5357515968218 +12.1656244968196 0 12.1656244968196 0 0 12.1656244968196 +11.1772011484323 0 11.1772011484323 0 0 11.1772011484323 +12.7709806123062 0 12.7709806123062 0 0 12.7709806123062 +11.3965967155343 0 11.3965967155343 0 0 11.3965967155343 +11.2189506973353 0 11.2189506973353 0 0 11.2189506973353 +12.0699413427248 0 12.0699413427248 0 0 12.0699413427248 +9.05735842979906 0 9.05735842979906 0 0 9.05735842979906 +12.7308575998764 0 12.7308575998764 0 0 12.7308575998764 +11.9420097263496 0 11.9420097263496 0 0 11.9420097263496 +10.2177754272777 0 10.2177754272777 0 0 10.2177754272777 +10.32094351209 0 10.32094351209 0 0 10.32094351209 +9.608261476645 0 9.608261476645 0 0 9.608261476645 +11.552242574238 0 11.552242574238 0 0 11.552242574238 +10.2177754272777 0 10.2177754272777 0 0 10.2177754272777 +8.62879195377837 0 8.62879195377837 0 0 8.62879195377837 +10.1883377931446 0 10.1883377931446 0 0 10.1883377931446 +8.49945666944076 0 8.49945666944076 0 0 8.49945666944076 +9.64562276407167 0 9.64562276407167 0 0 9.64562276407167 +8.65002665498281 0 8.65002665498281 0 0 8.65002665498281 +8.38553461311175 0 8.38553461311175 0 0 8.38553461311175 +9.63781364056505 0 9.63781364056505 0 0 9.63781364056505 +7.27266595210389 0 7.27266595210389 0 0 7.27266595210389 +7.33957669236778 0 7.33957669236778 0 0 7.33957669236778 +9.03460719327148 0 9.03460719327148 0 0 9.03460719327148 +7.80168133796328 0 7.80168133796328 0 0 7.80168133796328 +6.89958364725953 0 6.89958364725953 0 0 6.89958364725953 +7.26492971389745 0 7.26492971389745 0 0 7.26492971389745 +7.29197065521761 0 7.29197065521761 0 0 7.29197065521761 +8.16445695724643 0 8.16445695724643 0 0 8.16445695724643 +7.91399874633927 0 7.91399874633927 0 0 7.91399874633927 +6.90481712865612 0 6.90481712865612 0 0 6.90481712865612 +6.71911645911015 0 6.71911645911015 0 0 6.71911645911015 +7.6312915175132 0 7.6312915175132 0 0 7.6312915175132 +7.6312915175132 0 7.6312915175132 0 0 7.6312915175132 +6.73939125662358 0 6.73939125662358 0 0 6.73939125662358 +7.22332400973877 0 7.22332400973877 0 0 7.22332400973877 +6.39297176048657 0 6.39297176048657 0 0 6.39297176048657 +6.54902743987384 0 6.54902743987384 0 0 6.54902743987384 +5.64231663409425 0 5.64231663409425 0 0 5.64231663409425 +5.53539042060064 0 5.53539042060064 0 0 5.53539042060064 +6.39293897341182 0 6.39293897341182 0 0 6.39293897341182 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.08641319180349 0 7.08641319180349 0 0 7.08641319180349 +9.20515441328476 0 9.20515441328476 0 0 9.20515441328476 +6.9854164485737 0 6.9854164485737 0 0 6.9854164485737 +9.20515441328476 0 9.20515441328476 0 0 9.20515441328476 +6.71597786472557 0 6.71597786472557 0 0 6.71597786472557 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.03115272317648 0 7.03115272317648 0 0 7.03115272317648 +6.9854164485737 0 6.9854164485737 0 0 6.9854164485737 +6.16362626654936 0 6.16362626654936 0 0 6.16362626654936 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.84895190355309 0 5.84895190355309 0 0 5.84895190355309 +7.22330187759079 0 7.22330187759079 0 0 7.22330187759079 +6.67848147422251 0 6.67848147422251 0 0 6.67848147422251 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.22330187759079 0 7.22330187759079 0 0 7.22330187759079 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +6.08441127109028 0 6.08441127109028 0 0 6.08441127109028 +6.67848147422251 0 6.67848147422251 0 0 6.67848147422251 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.21510689167427 0 7.21510689167427 0 0 7.21510689167427 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +6.27111973025646 0 6.27111973025646 0 0 6.27111973025646 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.41355510345043 0 7.41355510345043 0 0 7.41355510345043 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.21510689167427 0 7.21510689167427 0 0 7.21510689167427 +6.084408665257 0 6.084408665257 0 0 6.084408665257 +8.81190570321625 0 8.81190570321625 0 0 8.81190570321625 +7.41355510345043 0 7.41355510345043 0 0 7.41355510345043 +6.67848259861007 0 6.67848259861007 0 0 6.67848259861007 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +9.34225055396777 0 9.34225055396777 0 0 9.34225055396777 +7.53158570474282 0 7.53158570474282 0 0 7.53158570474282 +8.82872082292022 0 8.82872082292022 0 0 8.82872082292022 +7.22327125334313 0 7.22327125334313 0 0 7.22327125334313 +9.34225055396777 0 9.34225055396777 0 0 9.34225055396777 +8.82872082292022 0 8.82872082292022 0 0 8.82872082292022 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +6.08441859848178 0 6.08441859848178 0 0 6.08441859848178 +6.59888975955177 0 6.59888975955177 0 0 6.59888975955177 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +6.67848661032896 0 6.67848661032896 0 0 6.67848661032896 +7.22328285418812 0 7.22328285418812 0 0 7.22328285418812 +7.22328285418812 0 7.22328285418812 0 0 7.22328285418812 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.64528517534407 0 5.64528517534407 0 0 5.64528517534407 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +6.60551573137873 0 6.60551573137873 0 0 6.60551573137873 +5.64528517534407 0 5.64528517534407 0 0 5.64528517534407 +6.67848178807643 0 6.67848178807643 0 0 6.67848178807643 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +6.67848397035074 0 6.67848397035074 0 0 6.67848397035074 +6.92867283473714 0 6.92867283473714 0 0 6.92867283473714 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.11098964503026 0 7.11098964503026 0 0 7.11098964503026 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.11098964503026 0 7.11098964503026 0 0 7.11098964503026 +8.77819925465687 0 8.77819925465687 0 0 8.77819925465687 +7.28429054177821 0 7.28429054177821 0 0 7.28429054177821 +5.54925353308947 0 5.54925353308947 0 0 5.54925353308947 +6.67848397035074 0 6.67848397035074 0 0 6.67848397035074 +9.52634995787169 0 9.52634995787169 0 0 9.52634995787169 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +9.99761494389708 0 9.99761494389708 0 0 9.99761494389708 +8.88188130139307 0 8.88188130139307 0 0 8.88188130139307 +9.99761494389708 0 9.99761494389708 0 0 9.99761494389708 +9.52634995787169 0 9.52634995787169 0 0 9.52634995787169 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +8.88188130139307 0 8.88188130139307 0 0 8.88188130139307 +6.26499824519641 0 6.26499824519641 0 0 6.26499824519641 +6.36215644962054 0 6.36215644962054 0 0 6.36215644962054 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +6.67848311836998 0 6.67848311836998 0 0 6.67848311836998 +7.22327535944186 0 7.22327535944186 0 0 7.22327535944186 +7.22327535944186 0 7.22327535944186 0 0 7.22327535944186 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.64528712612 0 5.64528712612 0 0 5.64528712612 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.64528712612 0 5.64528712612 0 0 5.64528712612 +6.44828520113487 0 6.44828520113487 0 0 6.44828520113487 +7.57432984193783 0 7.57432984193783 0 0 7.57432984193783 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.66265191538428 0 7.66265191538428 0 0 7.66265191538428 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.66265191538428 0 7.66265191538428 0 0 7.66265191538428 +6.67848188990508 0 6.67848188990508 0 0 6.67848188990508 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.64528794566134 0 5.64528794566134 0 0 5.64528794566134 +7.22327536080963 0 7.22327536080963 0 0 7.22327536080963 +6.67848249341106 0 6.67848249341106 0 0 6.67848249341106 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +7.22327536080963 0 7.22327536080963 0 0 7.22327536080963 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.64528794566134 0 5.64528794566134 0 0 5.64528794566134 +6.08441172274707 0 6.08441172274707 0 0 6.08441172274707 +6.67848249341106 0 6.67848249341106 0 0 6.67848249341106 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.61685588206789 0 5.61685588206789 0 0 5.61685588206789 +11.321595174017 0 11.321595174017 0 0 11.321595174017 +11.321595174017 0 11.321595174017 0 0 11.321595174017 +5.64971993643154 0 5.64971993643154 0 0 5.64971993643154 +5.64971993643154 0 5.64971993643154 0 0 5.64971993643154 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.81843417576192 0 5.81843417576192 0 0 5.81843417576192 +5.56752613368679 0 5.56752613368679 0 0 5.56752613368679 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +6.20162127289618 0 6.20162127289618 0 0 6.20162127289618 +5.69225677384929 0 5.69225677384929 0 0 5.69225677384929 +5.66174382148019 0 5.66174382148019 0 0 5.66174382148019 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +6.61494201747394 0 6.61494201747394 0 0 6.61494201747394 +5.69784205952621 0 5.69784205952621 0 0 5.69784205952621 +6.61494201747394 0 6.61494201747394 0 0 6.61494201747394 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 +5.53505395873405 0 5.53505395873405 0 0 5.53505395873405 + + +End diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/materials_2D.json b/applications/MeshingApplication/tests/mmg_lagrangian_test/materials_2D.json new file mode 100644 index 000000000000..e2c9642305a7 --- /dev/null +++ b/applications/MeshingApplication/tests/mmg_lagrangian_test/materials_2D.json @@ -0,0 +1,19 @@ +{ + "properties": [{ + "model_part_name": "Parts_Parts_Auto1", + "properties_id": 1, + "Material": { + "name": "Material", + "constitutive_law": { + "name": "KratosMultiphysics.StructuralMechanicsApplication.LinearElasticPlaneStrain2DLaw" + }, + "Variables": { + "KratosMultiphysics.YOUNG_MODULUS": 2.06900E+11, + "KratosMultiphysics.POISSON_RATIO": 2.90000E-01, + "KratosMultiphysics.THICKNESS": 1.00000, + "KratosMultiphysics.DENSITY": 7.85000E+03 + }, + "Tables": {} + } + }] +} diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/materials_3D.json b/applications/MeshingApplication/tests/mmg_lagrangian_test/materials_3D.json new file mode 100644 index 000000000000..6c437f078468 --- /dev/null +++ b/applications/MeshingApplication/tests/mmg_lagrangian_test/materials_3D.json @@ -0,0 +1,18 @@ +{ + "properties": [{ + "model_part_name": "Parts_Parts_Auto1", + "properties_id": 2, + "Material": { + "name": "Material", + "constitutive_law": { + "name": "KratosMultiphysics.StructuralMechanicsApplication.LinearElastic3DLaw" + }, + "Variables": { + "KratosMultiphysics.YOUNG_MODULUS": 2.06900E+11, + "KratosMultiphysics.POISSON_RATIO": 2.90000E-01, + "KratosMultiphysics.DENSITY": 7.85000E+03 + }, + "Tables": {} + } + }] +} diff --git a/applications/MeshingApplication/tests/mmg_lagrangian_test/materials_plastic_2D.json b/applications/MeshingApplication/tests/mmg_lagrangian_test/materials_plastic_2D.json new file mode 100644 index 000000000000..8f8027d76077 --- /dev/null +++ b/applications/MeshingApplication/tests/mmg_lagrangian_test/materials_plastic_2D.json @@ -0,0 +1,18 @@ +{ + "properties": [{ + "model_part_name": "Parts_Parts_Auto1", + "properties_id": 1, + "Material": { + "name": "Material", + "constitutive_law": { + "name": "KratosMultiphysics.StructuralMechanicsApplication.LinearElasticPlaneStrain2DLaw" + }, + "Variables": { + "KratosMultiphysics.YOUNG_MODULUS": 1.00000E+03, + "KratosMultiphysics.POISSON_RATIO": 3.00000E-01, + "KratosMultiphysics.THICKNESS": 1.00000 + }, + "Tables": {} + } + }] +} diff --git a/applications/MeshingApplication/tests/test_MeshingApplication.py b/applications/MeshingApplication/tests/test_MeshingApplication.py index 60a3f365dc40..00f8d9285a52 100644 --- a/applications/MeshingApplication/tests/test_MeshingApplication.py +++ b/applications/MeshingApplication/tests/test_MeshingApplication.py @@ -1,28 +1,41 @@ # import Kratos import KratosMultiphysics -import KratosMultiphysics.ExternalSolversApplication -import KratosMultiphysics.FluidDynamicsApplication -import KratosMultiphysics.MeshingApplication +import KratosMultiphysics.MeshingApplication as MeshingApplication +try: + import KratosMultiphysics.ExternalSolversApplication as ExternalSolversApplication + missing_external_solver_dependencies = False +except ImportError as e: + missing_external_solver_dependencies = True +try: + import KratosMultiphysics.FluidDynamicsApplication as FluidDynamicsApplication + missing_external_fluid_dependencies = False +except ImportError as e: + missing_external_fluid_dependencies = True +try: + import KratosMultiphysics.StructuralMechanicsApplication as StructuralMechanicsApplication + missing_external_solid_dependencies = False +except ImportError as e: + missing_external_solid_dependencies = True # Import Kratos "wrapper" for unittests import KratosMultiphysics.KratosUnittest as KratosUnittest # Import the tests o test_classes to create the suits ## SMALL TESTS -from test_refine import TestRedistance as TTestRedistance -from SmallTests import TwoDHessianTest as TTwoDHessianTest -from SmallTests import ThreeDHessianTest as TThreeDHessianTest -from SmallTests import TwoDCavityTest as TTwoDCavityTest -from SmallTests import CoarseSphereTest as TCoarseSphereTest -from SmallTests import TwoDDynamicBeamTest as TTwoDDynamicBeamTest -from SmallTests import ThreeDDynamicBeamTest as TThreeDDynamicBeamTest -from SmallTests import TwoDDynamicPlasticBeamTest as TTwoDDynamicPlasticBeamTest +from test_refine import TestRedistance as TTestRedistance +from test_remesh_sphere import TestRemeshMMG as TTestRemeshMMG +from SmallTests import TwoDHessianTest as TTwoDHessianTest +from SmallTests import ThreeDHessianTest as TThreeDHessianTest +from SmallTests import TwoDCavityTest as TTwoDCavityTest +from SmallTests import TwoDDynamicBeamTest as TTwoDDynamicBeamTest +from SmallTests import ThreeDDynamicBeamTest as TThreeDDynamicBeamTest +from SmallTests import TwoDDynamicPlasticBeamTest as TTwoDDynamicPlasticBeamTest ## NIGHTLY TESTS -from NightlyTests import StanfordBunnyTest as TStanfordBunnyTest +from NightlyTests import StanfordBunnyTest as TStanfordBunnyTest ## VALIDATION TESTS -from ValidationTests import TwoDSphereRemeshedChannelTest as TTwoDSphereRemeshedChannelTest +from ValidationTests import TwoDSphereRemeshedChannelTest as TTwoDSphereRemeshedChannelTest from ValidationTests import ThreeDSphereRemeshedChannelTest as TThreeDSphereRemeshedChannelTest def AssambleTestSuites(): @@ -44,58 +57,68 @@ def AssambleTestSuites(): smallSuite.addTest(TTestRedistance('test_refine_all')) smallSuite.addTest(TTestRedistance('test_refine_half')) smallSuite.addTest(TTestRedistance('test_refine_half_and_improve')) - if( hasattr(KratosMultiphysics.MeshingApplication, "MmgUtility2D") ): - smallSuite.addTest(TTwoDHessianTest('test_execution')) - smallSuite.addTest(TThreeDHessianTest('test_execution')) - smallSuite.addTest(TTwoDCavityTest('test_execution')) - smallSuite.addTest(TCoarseSphereTest('test_execution')) - smallSuite.addTest(TTwoDDynamicBeamTest('test_execution')) - smallSuite.addTest(TThreeDDynamicBeamTest('test_execution')) - smallSuite.addTest(TTwoDDynamicPlasticBeamTest('test_execution')) + if( hasattr(MeshingApplication, "MmgProcess2D") ): + if (missing_external_fluid_dependencies == False): + smallSuite.addTest(TTwoDHessianTest('test_execution')) + smallSuite.addTest(TThreeDHessianTest('test_execution')) + smallSuite.addTest(TTwoDCavityTest('test_execution')) + smallSuite.addTest(TTestRemeshMMG('test_remesh_sphere')) + if (missing_external_solid_dependencies == False): + smallSuite.addTest(TTwoDDynamicBeamTest('test_execution')) + smallSuite.addTest(TThreeDDynamicBeamTest('test_execution')) + smallSuite.addTest(TTwoDDynamicPlasticBeamTest('test_execution')) else: - print("MMG utility is not compiled and the corresponding tests will not be executed") + print("MMG process is not compiled and the corresponding tests will not be executed") # Create a test suit with the selected tests plus all small tests nightSuite = suites['nightly'] nightSuite.addTests(smallSuite) - if( hasattr(KratosMultiphysics.MeshingApplication, "MmgUtility2D") ): - nightSuite.addTest(TStanfordBunnyTest('test_execution')) + if( hasattr(MeshingApplication, "MmgProcess2D") ): + if (missing_external_fluid_dependencies == False): + nightSuite.addTest(TStanfordBunnyTest('test_execution')) else: - print("MMG utility is not compiled and the corresponding tests will not be executed") + print("MMG process is not compiled and the corresponding tests will not be executed") # For very long tests that should not be in nighly and you can use to validate validationSuite = suites['validation'] - if( hasattr(KratosMultiphysics.MeshingApplication, "MmgUtility2D") ): - validationSuite.addTest(TTwoDSphereRemeshedChannelTest('test_execution')) - validationSuite.addTest(TThreeDSphereRemeshedChannelTest('test_execution')) + if( hasattr(MeshingApplication, "MmgProcess2D") ): + if (missing_external_fluid_dependencies == False): + validationSuite.addTest(TTwoDSphereRemeshedChannelTest('test_execution')) + validationSuite.addTest(TThreeDSphereRemeshedChannelTest('test_execution')) else: - print("MMG utility is not compiled and the corresponding tests will not be executed") + print("MMG process is not compiled and the corresponding tests will not be executed") # Create a test suit that contains all the tests: allSuite = suites['all'] allSuite.addTests( KratosUnittest.TestLoader().loadTestsFromTestCases([ + TTestRedistance ]) ) - if( hasattr(KratosMultiphysics.MeshingApplication, "MmgUtility2D") ): - allSuite.addTests( - KratosUnittest.TestLoader().loadTestsFromTestCases([ - TTestRedistance, - TTwoDHessianTest, - TThreeDHessianTest, - TTwoDCavityTest, - TCoarseSphereTest, - TTwoDDynamicBeamTest, - #TThreeDDynamicBeamTest, - #TTwoDDynamicPlasticBeamTest, - #TStanfordBunnyTest, - #TTwoDSphereRemeshedChannelTest, - #TThreeDSphereRemeshedChannelTest, - ]) - ) + if( hasattr(MeshingApplication, "MmgProcess2D") ): + if (missing_external_fluid_dependencies == False): + allSuite.addTests( + KratosUnittest.TestLoader().loadTestsFromTestCases([ + TTwoDHessianTest, + TThreeDHessianTest, + TTwoDCavityTest, + TTestRemeshMMG, + #TStanfordBunnyTest, + #TTwoDSphereRemeshedChannelTest, + #TThreeDSphereRemeshedChannelTest, + ]) + ) + if (missing_external_solid_dependencies == False): + allSuite.addTests( + KratosUnittest.TestLoader().loadTestsFromTestCases([ + TTwoDDynamicBeamTest, + TThreeDDynamicBeamTest, + #TTwoDDynamicPlasticBeamTest, + ]) + ) else: - print("MMG utility is not compiled and the corresponding tests will not be executed") + print("MMG process is not compiled and the corresponding tests will not be executed") return suites diff --git a/applications/MeshingApplication/tests/test_remesh_sphere.py b/applications/MeshingApplication/tests/test_remesh_sphere.py new file mode 100644 index 000000000000..b775ad7fa7bf --- /dev/null +++ b/applications/MeshingApplication/tests/test_remesh_sphere.py @@ -0,0 +1,107 @@ +# We import the libraies +from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +import KratosMultiphysics +import KratosMultiphysics.MeshingApplication as MeshingApplication +import KratosMultiphysics.KratosUnittest as KratosUnittest + +class TestRemeshMMG(KratosUnittest.TestCase): + + def test_remesh_sphere(self): + # We create the model part + main_model_part = KratosMultiphysics.ModelPart("MainModelPart") + main_model_part.ProcessInfo.SetValue(KratosMultiphysics.DOMAIN_SIZE, 3) + + # We add the variables needed + main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.DISTANCE) + main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.DISTANCE_GRADIENT) + main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.NODAL_H) + main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.NODAL_AREA) + + for node in main_model_part.Nodes: + node.AddDof(KratosMultiphysics.DISTANCE) + + # We import the model main_model_part + KratosMultiphysics.ModelPartIO("mmg_eulerian_test/coarse_sphere_test").ReadModelPart(main_model_part) + + # We calculate the gradient of the distance variable + find_nodal_h = KratosMultiphysics.FindNodalHProcess(main_model_part) + find_nodal_h.Execute() + local_gradient = KratosMultiphysics.ComputeNodalGradientProcess3D(main_model_part, KratosMultiphysics.DISTANCE, KratosMultiphysics.DISTANCE_GRADIENT, KratosMultiphysics.NODAL_AREA) + local_gradient.Execute() + + # We set to zero the metric + ZeroVector = KratosMultiphysics.Vector(6) + ZeroVector[0] = 0.0 + ZeroVector[1] = 0.0 + ZeroVector[2] = 0.0 + ZeroVector[3] = 0.0 + ZeroVector[4] = 0.0 + ZeroVector[5] = 0.0 + + for node in main_model_part.Nodes: + node.SetValue(MeshingApplication.MMG_METRIC, ZeroVector) + + # We define a metric using the ComputeLevelSetSolMetricProcess + MetricParameters = KratosMultiphysics.Parameters(""" + { + "minimal_size" : 1.0e-1, + "enforce_current" : false, + "anisotropy_remeshing" : false, + "anisotropy_parameters" :{ + "hmin_over_hmax_anisotropic_ratio" : 0.15, + "boundary_layer_max_distance" : 1.0e-4, + "interpolation" : "Linear" + } + } + """) + metric_process = MeshingApplication.ComputeLevelSetSolMetricProcess3D(main_model_part, KratosMultiphysics.DISTANCE_GRADIENT, MetricParameters) + + metric_process.Execute() + + MMGParameters = KratosMultiphysics.Parameters(""" + { + "filename" : "mmg_eulerian_test/coarse_sphere_test", + "save_external_files" : true, + "echo_level" : 0 + } + """) + + # We create the remeshing utility + mmg_process = MeshingApplication.MmgProcess3D(main_model_part, MMGParameters) + + # We remesh + mmg_process.Execute() + + # Finally we export to GiD + from gid_output_process import GiDOutputProcess + gid_output = GiDOutputProcess(main_model_part, + "gid_output", + KratosMultiphysics.Parameters(""" + { + "result_file_configuration" : { + "gidpost_flags": { + "GiDPostMode": "GiD_PostBinary", + "WriteDeformedMeshFlag": "WriteUndeformed", + "WriteConditionsFlag": "WriteConditions", + "MultiFileFlag": "SingleFile" + }, + "nodal_results" : [] + } + } + """) + ) + + #gid_output.ExecuteInitialize() + #gid_output.ExecuteBeforeSolutionLoop() + #gid_output.ExecuteInitializeSolutionStep() + #gid_output.PrintOutput() + #gid_output.ExecuteFinalizeSolutionStep() + #gid_output.ExecuteFinalize() + + import filecmp + value = filecmp.cmp("mmg_eulerian_test/coarse_sphere_test_result.mesh", "mmg_eulerian_test/coarse_sphere_test_step=0.o.mesh") + self.assertTrue(value) + +if __name__ == '__main__': + KratosUnittest.main() diff --git a/applications/MultiScaleApplication/constitutive_laws/planestrain_from_3d_constitutive_law_adapter.h b/applications/MultiScaleApplication/constitutive_laws/planestrain_from_3d_constitutive_law_adapter.h index 4b669a07c013..45ec4e57566c 100644 --- a/applications/MultiScaleApplication/constitutive_laws/planestrain_from_3d_constitutive_law_adapter.h +++ b/applications/MultiScaleApplication/constitutive_laws/planestrain_from_3d_constitutive_law_adapter.h @@ -55,8 +55,8 @@ SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. #include "constitutive_law_adapter.h" #define CHECK_STRAIN_CALCULATION \ - if(rValues.GetOptions().Is(ConstitutiveLaw::COMPUTE_STRAIN)) { \ - std::cout << "ERROR: Constitutive Law Adapters work only with strains. The option COMPUTE_STRAIN is not supported" << std::endl; \ + if(rValues.GetOptions().Is(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN)) { \ + std::cout << "ERROR: Constitutive Law Adapters work only with strains. The option USE_ELEMENT_PROVIDED_STRAIN is not supported" << std::endl; \ return; \ } diff --git a/applications/MultiScaleApplication/constitutive_laws/planestress_from_3d_constitutive_law_adapter.h b/applications/MultiScaleApplication/constitutive_laws/planestress_from_3d_constitutive_law_adapter.h index fb938160f9fa..2a6fc9fba22d 100644 --- a/applications/MultiScaleApplication/constitutive_laws/planestress_from_3d_constitutive_law_adapter.h +++ b/applications/MultiScaleApplication/constitutive_laws/planestress_from_3d_constitutive_law_adapter.h @@ -56,8 +56,8 @@ SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. #include "constitutive_law_adapter.h" #define CHECK_STRAIN_CALCULATION \ - if(rValues.GetOptions().Is(ConstitutiveLaw::COMPUTE_STRAIN)) { \ - std::cout << "ERROR: Constitutive Law Adapters work only with strains. The option COMPUTE_STRAIN is not supported" << std::endl; \ + if(rValues.GetOptions().Is(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN)) { \ + std::cout << "ERROR: Constitutive Law Adapters work only with strains. The option USE_ELEMENT_PROVIDED_STRAIN is not supported" << std::endl; \ return; \ } diff --git a/applications/MultiScaleApplication/constitutive_laws/shell_from_3d_constitutive_law_adapter.h b/applications/MultiScaleApplication/constitutive_laws/shell_from_3d_constitutive_law_adapter.h index f5e10de6f042..7c2e2844effe 100644 --- a/applications/MultiScaleApplication/constitutive_laws/shell_from_3d_constitutive_law_adapter.h +++ b/applications/MultiScaleApplication/constitutive_laws/shell_from_3d_constitutive_law_adapter.h @@ -55,8 +55,8 @@ SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. #include "constitutive_law_adapter.h" #define CHECK_STRAIN_CALCULATION \ - if(rValues.GetOptions().Is(ConstitutiveLaw::COMPUTE_STRAIN)) { \ - std::cout << "ERROR: Constitutive Law Adapters work only with strains. The option COMPUTE_STRAIN is not supported" << std::endl; \ + if(rValues.GetOptions().Is(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN)) { \ + std::cout << "ERROR: Constitutive Law Adapters work only with strains. The option USE_ELEMENT_PROVIDED_STRAIN is not supported" << std::endl; \ return; \ } diff --git a/applications/PFEMapplication/CMakeLists.txt b/applications/PFEMapplication/CMakeLists.txt deleted file mode 100644 index c9c6f7063b92..000000000000 --- a/applications/PFEMapplication/CMakeLists.txt +++ /dev/null @@ -1,46 +0,0 @@ -set(CMAKE_INCLUDE_CURRENT_DIR ON) - -message("**** configuring KratosPFEMApplication ****") - -include_directories( ${CMAKE_SOURCE_DIR}/kratos ) - -## generate variables with the sources -set( KRATOS_PFEM_APPLICATION_SOURCES - ${CMAKE_CURRENT_SOURCE_DIR}/PFEM_application.cpp - ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/kratos_pfem_python_application.cpp - ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_meshers_to_python.cpp - ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_custom_utilities_to_python.cpp - ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_processes_to_python.cpp - ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_custom_io_to_python.cpp - - ${CMAKE_CURRENT_SOURCE_DIR}/custom_conditions/free_surface_cond2d.cpp -) - -############################################################### -## define library Kratos which defines the basic python interface -add_library(KratosPFEMApplication SHARED ${KRATOS_PFEM_APPLICATION_SOURCES}) -target_link_libraries(KratosPFEMApplication KratosCore ) -set_target_properties(KratosPFEMApplication PROPERTIES PREFIX "") - -# changing the .dll suffix to .pyd -if(${CMAKE_SYSTEM_NAME} MATCHES "Windows") - set_target_properties(KratosPFEMApplication PROPERTIES SUFFIX .pyd) -endif(${CMAKE_SYSTEM_NAME} MATCHES "Windows") - -# changing the .dylib suffix to .so -if(${CMAKE_SYSTEM_NAME} MATCHES "Darwin") - set_target_properties(KratosPFEMApplication PROPERTIES SUFFIX .so) -endif(${CMAKE_SYSTEM_NAME} MATCHES "Darwin") - -install(TARGETS KratosPFEMApplication DESTINATION libs ) - -if(${INSTALL_PYTHON_FILES} MATCHES ON) - get_filename_component (CURRENT_DIR_NAME ${CMAKE_CURRENT_SOURCE_DIR} NAME) - install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/python_scripts DESTINATION applications/${CURRENT_DIR_NAME} FILES_MATCHING PATTERN "*.py" PATTERN ".svn" EXCLUDE) -endif(${INSTALL_PYTHON_FILES} MATCHES ON) - -# get_property(inc_dirs DIRECTORY PROPERTY INCLUDE_DIRECTORIES) -# message("KratosIncompressibleFluidApplication subdir inc_dirs = ${inc_dirs}") - -# Add to the KratosMultiphisics Python module -install(FILES "${CMAKE_CURRENT_SOURCE_DIR}/PFEMApplication.py" DESTINATION KratosMultiphysics ) diff --git a/applications/PFEMapplication/PFEM_application.cpp b/applications/PFEMapplication/PFEM_application.cpp deleted file mode 100644 index ac88a539661a..000000000000 --- a/applications/PFEMapplication/PFEM_application.cpp +++ /dev/null @@ -1,72 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2008-05-06 15:11:09 $ -// Revision: $Revision: 1.6 $ -// -// - - - -// System includes - - -// External includes - - -// Project includes -#include "includes/define.h" - -#include "PFEM_application.h" -#include "includes/variables.h" -#include "geometries/triangle_2d_3.h" - - -namespace Kratos -{ - -/* KRATOS_CREATE_VARIABLE(double, NODAL_AREA) - KRATOS_CREATE_VARIABLE(double, NODAL_H) - KRATOS_CREATE_VARIABLE(double, IS_STRUCTURE) - KRATOS_CREATE_VARIABLE(double, IS_FLUID) - KRATOS_CREATE_VARIABLE(double, IS_BOUNDARY) - KRATOS_CREATE_VARIABLE(double, IS_FREE_SURFACE) - KRATOS_CREATE_VARIABLE(double, IS_FREE_SURFACE) - KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(NORMAL_TO_WALL) -*/ -// KRATOS_CREATE_VARIABLE(double, PRESSURE_OLD_IT) -// KRATOS_CREATE_VARIABLE(double, NODAL_MASS) -// KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(FRACT_VEL) -KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(VAUX) - -KratosPFEMApplication::KratosPFEMApplication(): - mFreeSurfaceCond2d(0, Element::GeometryType::Pointer(new Geometry >(Element::GeometryType::PointsArrayType(2 )))) -{} - - -void KratosPFEMApplication::Register() -{ - // calling base class register to register Kratos components - KratosApplication::Register(); - std::cout << "Initializing Kratos PFEMApplication... " << std::endl; - - /* KRATOS_REGISTER_VARIABLE( NODAL_AREA) - KRATOS_REGISTER_VARIABLE( NODAL_H) - KRATOS_REGISTER_VARIABLE( IS_STRUCTURE) - KRATOS_REGISTER_VARIABLE( IS_FLUID) - KRATOS_REGISTER_VARIABLE( IS_BOUNDARY) - KRATOS_REGISTER_VARIABLE( IS_FREE_SURFACE) - KRATOS_REGISTER_VARIABLE( IS_FREE_SURFACE) - KRATOS_REGISTER_3D_VARIABLE_WITH_COMPONENTS(NORMAL_TO_WALL) - */ - KRATOS_REGISTER_VARIABLE( NODAL_MASS) - KRATOS_REGISTER_3D_VARIABLE_WITH_COMPONENTS(VAUX) - - KRATOS_REGISTER_CONDITION("FreeSurfaceCond2d", mFreeSurfaceCond2d); -} - - - -} // namespace Kratos. - - diff --git a/applications/PFEMapplication/PFEM_application.h b/applications/PFEMapplication/PFEM_application.h deleted file mode 100644 index c0ecd70bbef2..000000000000 --- a/applications/PFEMapplication/PFEM_application.h +++ /dev/null @@ -1,262 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2008-03-05 09:39:14 $ -// Revision: $Revision: 1.5 $ -// -// - - -#if !defined(KRATOS_KRATOS_RICCARDOS_APPLICATION_H_INCLUDED ) -#define KRATOS_KRATOS_RICCARDOS_APPLICATION_H_INCLUDED - - - -// System includes -#include -#include - - -// External includes - - -// Project includes -#include "includes/define.h" -#include "includes/kratos_application.h" - -#include "includes/variables.h" -#include "includes/condition.h" -//#include "custom_elements/updated_lagrangian_fluid.h" -#include "custom_conditions/free_surface_cond2d.h" - -#include "../../kratos/includes/dem_variables.h" //TODO: to be removed eventually - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -// Variables definition -/* KRATOS_DEFINE_VARIABLE(double, NODAL_AREA) - KRATOS_DEFINE_VARIABLE(double, NODAL_H) - KRATOS_DEFINE_VARIABLE(double, IS_STRUCTURE) - KRATOS_DEFINE_VARIABLE(double, IS_FLUID) - KRATOS_DEFINE_VARIABLE(double, IS_BOUNDARY) - KRATOS_DEFINE_VARIABLE(double, IS_FREE_SURFACE) - KRATOS_DEFINE_VARIABLE(double, IS_FREE_SURFACE) - KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS(NORMAL_TO_WALL) -*/ -// KRATOS_DEFINE_VARIABLE(double, PRESSURE_OLD_IT) -// KRATOS_DEFINE_VARIABLE(double, NODAL_MASS) -// KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS(FRACT_VEL) -KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS(VAUX) - -///@} -///@name Type Definitions -///@{ - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. -*/ -class KratosPFEMApplication : public KratosApplication -{ -public: - ///@name Type Definitions - ///@{ - - - /// Pointer definition of KratosPFEMApplication - KRATOS_CLASS_POINTER_DEFINITION(KratosPFEMApplication); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - KratosPFEMApplication(); - - /// Destructor. - virtual ~KratosPFEMApplication() {} - - - ///@} - ///@name Operators - ///@{ - - - ///@} - ///@name Operations - ///@{ - - virtual void Register(); - - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "KratosPFEMApplication"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << Info(); - PrintData(rOStream); - } - - ///// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - KRATOS_WATCH("in KratosPFEMApplication"); - KRATOS_WATCH(KratosComponents::GetComponents().size() ); - rOStream << "Variables:" << std::endl; - KratosComponents().PrintData(rOStream); - rOStream << std::endl; - rOStream << "Elements:" << std::endl; - KratosComponents().PrintData(rOStream); - rOStream << std::endl; - rOStream << "Conditions:" << std::endl; - KratosComponents().PrintData(rOStream); - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - //const UpdatedLagrangianFluid mUpdatedLagrangianFluid2D; - const FreeSurfaceCond2d mFreeSurfaceCond2d; - - - - ///@} - ///@name Private Operators - ///@{ - - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - KratosPFEMApplication& operator=(KratosPFEMApplication const& rOther); - - /// Copy constructor. - KratosPFEMApplication(KratosPFEMApplication const& rOther); - - - ///@} - -}; // Class KratosPFEMApplication - -///@} - - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - -///@} - - -} // namespace Kratos. - -#endif // KRATOS_KRATOS_RICCARDOS_APPLICATION_H_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_conditions/free_surface_cond2d.cpp b/applications/PFEMapplication/custom_conditions/free_surface_cond2d.cpp deleted file mode 100644 index 59a32e03de32..000000000000 --- a/applications/PFEMapplication/custom_conditions/free_surface_cond2d.cpp +++ /dev/null @@ -1,253 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last modified by: $Author: rrossi $ -// Date: $Date: 2007-03-28 17:37:14 $ -// Revision: $Revision: 1.3 $ -// -// - - -// System includes - - -// External includes - - -// Project includes -#include "includes/define.h" -#include "custom_conditions/free_surface_cond2d.h" -#include "utilities/math_utils.h" -#include "PFEM_application.h" -#include "includes/deprecated_variables.h" -#include "includes/cfd_variables.h" - -namespace Kratos -{ -//************************************************************************************ -//************************************************************************************ -FreeSurfaceCond2d::FreeSurfaceCond2d(IndexType NewId, GeometryType::Pointer pGeometry) - : Condition(NewId, pGeometry) -{ - //DO NOT ADD DOFS HERE!!! -} - -//************************************************************************************ -//************************************************************************************ -FreeSurfaceCond2d::FreeSurfaceCond2d(IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) - : Condition(NewId, pGeometry, pProperties) -{ -} - -Condition::Pointer FreeSurfaceCond2d::Create(IndexType NewId, NodesArrayType const& ThisNodes, PropertiesType::Pointer pProperties) const -{ - return Condition::Pointer(new FreeSurfaceCond2d(NewId, GetGeometry().Create(ThisNodes), pProperties)); -} - -FreeSurfaceCond2d::~FreeSurfaceCond2d() -{ -} - - -//************************************************************************************ -//************************************************************************************ -void FreeSurfaceCond2d::CalculateRightHandSide(VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo) -{ - //calculation flags - unsigned int FractionalStepNumber = rCurrentProcessInfo[FRACTIONAL_STEP]; - - if(FractionalStepNumber == 4) //pressure step - { - bool CalculateStiffnessMatrixFlag = false; - bool CalculateResidualVectorFlag = true; - MatrixType temp = Matrix(); - CalculateAll(temp, rRightHandSideVector, rCurrentProcessInfo, CalculateStiffnessMatrixFlag, CalculateResidualVectorFlag); - } - else - { - if(rRightHandSideVector.size() != 0) - rRightHandSideVector.resize(0,false); - } -} - -//************************************************************************************ -//************************************************************************************ -void FreeSurfaceCond2d::CalculateLocalSystem(MatrixType& rLeftHandSideMatrix, VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo) -{ - //calculation flags - bool CalculateStiffnessMatrixFlag = true; - bool CalculateResidualVectorFlag = true; - - unsigned int FractionalStepNumber = rCurrentProcessInfo[FRACTIONAL_STEP]; - -// KRATOS_WATCH(FractionalStepNumber); - - if(FractionalStepNumber == 4) //pressure step - { - CalculateAll(rLeftHandSideMatrix, rRightHandSideVector, rCurrentProcessInfo, CalculateStiffnessMatrixFlag, CalculateResidualVectorFlag); - } - else - { - if(rLeftHandSideMatrix.size1() != 0) - { - rLeftHandSideMatrix.resize(0,0,false); - rRightHandSideVector.resize(0,false); - } - } -} - -//************************************************************************************ -//************************************************************************************ -void FreeSurfaceCond2d::CalculateAll(MatrixType& rLeftHandSideMatrix, VectorType& rRightHandSideVector, - ProcessInfo& rCurrentProcessInfo, - bool CalculateStiffnessMatrixFlag, - bool CalculateResidualVectorFlag) -{ - KRATOS_TRY - - unsigned int number_of_nodes = GetGeometry().size(); - unsigned int MatSize=number_of_nodes; - - //calculate lenght - double x21 = GetGeometry()[1].X() - GetGeometry()[0].X(); - double y21 = GetGeometry()[1].Y() - GetGeometry()[0].Y(); - double lenght = x21*x21 + y21*y21; - lenght = sqrt(lenght); - - double dt = rCurrentProcessInfo[DELTA_TIME]; - - //proposal by riccardo - double density = 0.5*(GetGeometry()[0].FastGetSolutionStepValue(DENSITY) + GetGeometry()[1].FastGetSolutionStepValue(DENSITY)); - - double sound_speed = 10.0; -// double K = density * sound_speed; //K = density * sound_speed*sound_speed - - //chapuza to make this of the same order of the other terms in the system independently on the deltatime -// double K = density * 0.0001 / (dt*dt); //.this would give a c = 1 for dt = 0.01...which we tested to be good - -// K = 1000; - - - - - if (CalculateStiffnessMatrixFlag == true) //calculation of the matrix is required - { - if(rLeftHandSideMatrix.size1() != MatSize ) - rLeftHandSideMatrix.resize(MatSize,MatSize,false); - noalias(rLeftHandSideMatrix) = ZeroMatrix(MatSize,MatSize); -// if(GetGeometry()[0].FastGetSolutionStepValue(IS_FREE_SURFACE) == 1) -// rLeftHandSideMatrix(0,0) = 0.5 * lenght*lenght / ( K *dt); -// if(GetGeometry()[1].FastGetSolutionStepValue(IS_FREE_SURFACE) == 1) -// rLeftHandSideMatrix(1,1) = 0.5 * lenght*lenght / ( K * dt); - if(GetGeometry()[0].FastGetSolutionStepValue(IS_FREE_SURFACE) == 1) - rLeftHandSideMatrix(0,0) = 0.5 * lenght / ( density * sound_speed * dt ); - if(GetGeometry()[1].FastGetSolutionStepValue(IS_FREE_SURFACE) == 1) - rLeftHandSideMatrix(1,1) = 0.5 * lenght / ( density * sound_speed *dt ); - } - - if (CalculateResidualVectorFlag == true) //calculation of the matrix is required - { - if(rRightHandSideVector.size() != MatSize ) - rRightHandSideVector.resize(MatSize,false); - -// noalias(rRightHandSideVector) = ZeroVector(2); - - array_1d temp; -// temp[0] = GetGeometry()[0].FastGetSolutionStepValue(PRESSURE,1) - GetGeometry()[0].FastGetSolutionStepValue(PRESSURE); -// temp[1] = GetGeometry()[1].FastGetSolutionStepValue(PRESSURE,1) - GetGeometry()[1].FastGetSolutionStepValue(PRESSURE); - temp[0] = GetGeometry()[0].FastGetSolutionStepValue(PRESSURE_OLD_IT) - GetGeometry()[0].FastGetSolutionStepValue(PRESSURE); - temp[1] = GetGeometry()[1].FastGetSolutionStepValue(PRESSURE_OLD_IT) - GetGeometry()[1].FastGetSolutionStepValue(PRESSURE); - noalias(rRightHandSideVector) = prod( rLeftHandSideMatrix , temp); - } -// KRATOS_WATCH(rLeftHandSideMatrix); -// KRATOS_WATCH(rRightHandSideVector); - - KRATOS_CATCH("") -} - - - -//************************************************************************************ -//************************************************************************************ -void FreeSurfaceCond2d::EquationIdVector(EquationIdVectorType& rResult, ProcessInfo& CurrentProcessInfo) -{ - unsigned int number_of_nodes = GetGeometry().PointsNumber(); - - unsigned int FractionalStepNumber = CurrentProcessInfo[FRACTIONAL_STEP]; - - if(FractionalStepNumber == 4) //pressure step - { - if(rResult.size() != number_of_nodes) - rResult.resize(number_of_nodes,false); - for (unsigned int i=0; i> (std::istream& rIStream, - FreeSurfaceCond2d& rThis); -*/ -/// output stream function -/* inline std::ostream& operator << (std::ostream& rOStream, - const FreeSurfaceCond2d& rThis) - { - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; - }*/ -///@} - -} // namespace Kratos. - -#endif // KRATOS_FREE_SURFACE_2D_CONDITION_H_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_conditions/pressure_cond.cpp b/applications/PFEMapplication/custom_conditions/pressure_cond.cpp deleted file mode 100755 index a03541d078ee..000000000000 --- a/applications/PFEMapplication/custom_conditions/pressure_cond.cpp +++ /dev/null @@ -1,113 +0,0 @@ -// -// Project Name: Kratos -// Last modified by: $Author: rrossi $ -// Date: $Date: 2007-01-23 15:38:00 $ -// Revision: $Revision: 1.1 $ -// -// - - -// System includes - - -// External includes - - -// Project includes -#include "includes/define.h" -#include "custom_conditions/pressure_cond.h" -#include "utilities/math_utils.h" -#include "PFEM_application.h" - -namespace Kratos -{ -//************************************************************************************ -//************************************************************************************ -PressureCond::PressureCond(IndexType NewId, GeometryType::Pointer pGeometry) - : Condition(NewId, pGeometry) -{ - //DO NOT ADD DOFS HERE!!! -} - -//************************************************************************************ -//************************************************************************************ -PressureCond::PressureCond(IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) - : Condition(NewId, pGeometry, pProperties) -{ -} - -Condition::Pointer PressureCond::Create(IndexType NewId, NodesArrayType const& ThisNodes, PropertiesType::Pointer pProperties) const -{ - return Condition::Pointer(new PressureCond(NewId, GetGeometry().Create(ThisNodes), pProperties)); -} - -PressureCond::~PressureCond() -{ -} - - -//************************************************************************************ -//************************************************************************************ -void PressureCond::CalculateRightHandSide(VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo) -{ - - if(rRightHandSideVector.size() != 2) - rRightHandSideVector.resize(2,false); - //there can be a problem if I make the size of rHS vector = 2, coz the force has 3 components - comp. in Z =0 - const array_1d& fp = GetGeometry()[0].FastGetSolutionStepValue(PRESSURE_FORCE); - - rRightHandSideVector[0] = -fp[0]; - rRightHandSideVector[1] = -fp[1]; - -} - -//************************************************************************************ -//************************************************************************************ -void PressureCond::CalculateLocalSystem(MatrixType& rLeftHandSideMatrix, VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo) -{ - if(rLeftHandSideMatrix.size1() != 2) - { - rLeftHandSideMatrix.resize(2,2,false); - } - noalias(rLeftHandSideMatrix) = ZeroMatrix(2,2); - - if(rRightHandSideVector.size() != 2) - rRightHandSideVector.resize(2,false); - - const array_1d& fp = GetGeometry()[0].FastGetSolutionStepValue(PRESSURE_FORCE); - - - rRightHandSideVector[0] = -fp[0]; - rRightHandSideVector[1] = -fp[1]; - - -} - - - -//************************************************************************************ -//************************************************************************************ -void PressureCond::EquationIdVector(EquationIdVectorType& rResult, ProcessInfo& CurrentProcessInfo) -{ - if(rResult.size() != 2) - rResult.resize(2); - - rResult[0] = (GetGeometry()[0].GetDof(DISPLACEMENT_X)).EquationId(); - rResult[1] = (GetGeometry()[0].GetDof(DISPLACEMENT_Y).EquationId()); - -} - -//************************************************************************************ -//************************************************************************************ -void PressureCond::GetDofList(DofsVectorType& ConditionalDofList,ProcessInfo& CurrentProcessInfo) -{ - if(ConditionalDofList.size() != 2) - ConditionalDofList.resize(2); - - ConditionalDofList[0] = (GetGeometry()[0].pGetDof(DISPLACEMENT_X)); - ConditionalDofList[1] = (GetGeometry()[0].pGetDof(DISPLACEMENT_Y)); - -} -} // Namespace Kratos - - diff --git a/applications/PFEMapplication/custom_conditions/pressure_cond.h b/applications/PFEMapplication/custom_conditions/pressure_cond.h deleted file mode 100755 index 66e223a1fbae..000000000000 --- a/applications/PFEMapplication/custom_conditions/pressure_cond.h +++ /dev/null @@ -1,241 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-01-23 15:38:00 $ -// Revision: $Revision: 1.1 $ -// -// - - -#if !defined(KRATOS_PRESSURE_CONDITION_H_INCLUDED ) -#define KRATOS_PRESSURE_CONDITION_H_INCLUDED - - - -// System includes - - -// External includes -#include "boost/smart_ptr.hpp" - - -// Project includes -#include "includes/define.h" -#include "includes/condition.h" -#include "includes/ublas_interface.h" -#include "includes/variables.h" - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. -*/ -class PressureCond - : public Condition -{ -public: - ///@name Type Definitions - ///@{ - - /// Counted pointer of PressureCond - KRATOS_CLASS_POINTER_DEFINITION(PressureCond); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - PressureCond(IndexType NewId, GeometryType::Pointer pGeometry); - PressureCond(IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties); - - /// Destructor. - virtual ~PressureCond(); - - - ///@} - ///@name Operators - ///@{ - - - ///@} - ///@name Operations - ///@{ - - Condition::Pointer Create(IndexType NewId, NodesArrayType const& ThisNodes, PropertiesType::Pointer pProperties) const; - - void CalculateLocalSystem(MatrixType& rLeftHandSideMatrix, VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo); - - void CalculateRightHandSide(VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo); - //virtual void CalculateLeftHandSide(MatrixType& rLeftHandSideMatrix, ProcessInfo& rCurrentProcessInfo); - - void EquationIdVector(EquationIdVectorType& rResult, ProcessInfo& rCurrentProcessInfo); - - void GetDofList(DofsVectorType& ConditionalDofList,ProcessInfo& CurrentProcessInfo); - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. -// virtual String Info() const; - - /// Print information about this object. -// virtual void PrintInfo(std::ostream& rOStream) const; - - /// Print object's data. -// virtual void PrintData(std::ostream& rOStream) const; - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - - - - ///@} - ///@name Private Operators - ///@{ - - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - //PressureCond& operator=(const PressureCond& rOther); - - /// Copy constructor. - //PressureCond(const PressureCond& rOther); - - - ///@} - -}; // Class PressureCond - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -/* inline std::istream& operator >> (std::istream& rIStream, - PressureCond& rThis); -*/ -/// output stream function -/* inline std::ostream& operator << (std::ostream& rOStream, - const PressureCond& rThis) - { - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; - }*/ -///@} - -} // namespace Kratos. - -#endif // KRATOS_PRESSURE_CONDITION_H_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_conditions/pressure_cond3d.cpp b/applications/PFEMapplication/custom_conditions/pressure_cond3d.cpp deleted file mode 100755 index 82b265beb51e..000000000000 --- a/applications/PFEMapplication/custom_conditions/pressure_cond3d.cpp +++ /dev/null @@ -1,115 +0,0 @@ -// -// Project Name: Kratos -// Last modified by: $Author: rrossi $ -// Date: $Date: 2007-01-23 15:38:00 $ -// Revision: $Revision: 1.1 $ -// -// - - -// System includes - - -// External includes - - -// Project includes -#include "includes/define.h" -#include "custom_conditions/pressure_cond3d.h" -#include "utilities/math_utils.h" -#include "PFEM_application.h" - -namespace Kratos -{ -//************************************************************************************ -//************************************************************************************ -PressureCond3D::PressureCond3D(IndexType NewId, GeometryType::Pointer pGeometry) - : Condition(NewId, pGeometry) -{ - //DO NOT ADD DOFS HERE!!! -} - -//************************************************************************************ -//************************************************************************************ -PressureCond3D::PressureCond3D(IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) - : Condition(NewId, pGeometry, pProperties) -{ -} - -Condition::Pointer PressureCond3D::Create(IndexType NewId, NodesArrayType const& ThisNodes, PropertiesType::Pointer pProperties) const -{ - return Condition::Pointer(new PressureCond3D(NewId, GetGeometry().Create(ThisNodes), pProperties)); -} - -PressureCond3D::~PressureCond3D() -{ -} - - -//************************************************************************************ -//************************************************************************************ -void PressureCond3D::CalculateRightHandSide(VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo) -{ - - if(rRightHandSideVector.size() != 3) - rRightHandSideVector.resize(3,false); - //there can be a problem if I make the size of rHS vector = 2, coz the force has 3 components - comp. in Z =0 - const array_1d& fp = GetGeometry()[0].FastGetSolutionStepValue(PRESSURE_FORCE); - - rRightHandSideVector[0] = -fp[0]; - rRightHandSideVector[1] = -fp[1]; - rRightHandSideVector[2] = -fp[2]; - -} - -//************************************************************************************ -//************************************************************************************ -void PressureCond3D::CalculateLocalSystem(MatrixType& rLeftHandSideMatrix, VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo) -{ - if(rLeftHandSideMatrix.size1() != 3) - { - rLeftHandSideMatrix.resize(3,3,false); - } - noalias(rLeftHandSideMatrix) = ZeroMatrix(3,3); - - if(rRightHandSideVector.size() != 3) - rRightHandSideVector.resize(3,false); - - const array_1d& fp = GetGeometry()[0].FastGetSolutionStepValue(PRESSURE_FORCE); - - - rRightHandSideVector[0] = -fp[0]; - rRightHandSideVector[1] = -fp[1]; - rRightHandSideVector[2] = -fp[2]; - -} - - - -//************************************************************************************ -//************************************************************************************ -void PressureCond3D::EquationIdVector(EquationIdVectorType& rResult, ProcessInfo& CurrentProcessInfo) -{ - if(rResult.size() != 3) - rResult.resize(3); - - rResult[0] = (GetGeometry()[0].GetDof(DISPLACEMENT_X)).EquationId(); - rResult[1] = (GetGeometry()[0].GetDof(DISPLACEMENT_Y).EquationId()); - rResult[2] = (GetGeometry()[0].GetDof(DISPLACEMENT_Z).EquationId()); -} - -//************************************************************************************ -//************************************************************************************ -void PressureCond3D::GetDofList(DofsVectorType& ConditionalDofList,ProcessInfo& CurrentProcessInfo) -{ - if(ConditionalDofList.size() != 3) - ConditionalDofList.resize(3); - - ConditionalDofList[0] = (GetGeometry()[0].pGetDof(DISPLACEMENT_X)); - ConditionalDofList[1] = (GetGeometry()[0].pGetDof(DISPLACEMENT_Y)); - ConditionalDofList[2] = (GetGeometry()[0].pGetDof(DISPLACEMENT_Z)); - -} -} // Namespace Kratos - - diff --git a/applications/PFEMapplication/custom_conditions/pressure_cond3d.h b/applications/PFEMapplication/custom_conditions/pressure_cond3d.h deleted file mode 100755 index dc340ee6e7be..000000000000 --- a/applications/PFEMapplication/custom_conditions/pressure_cond3d.h +++ /dev/null @@ -1,241 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-01-23 15:38:00 $ -// Revision: $Revision: 1.1 $ -// -// - - -#if !defined(KRATOS_PRESSURE_CONDITION3D_H_INCLUDED ) -#define KRATOS_PRESSURE_CONDITION3D_H_INCLUDED - - - -// System includes - - -// External includes -#include "boost/smart_ptr.hpp" - - -// Project includes -#include "includes/define.h" -#include "includes/condition.h" -#include "includes/ublas_interface.h" -#include "includes/variables.h" - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. -*/ -class PressureCond3D - : public Condition -{ -public: - ///@name Type Definitions - ///@{ - - /// Counted pointer of PressureCond3D - KRATOS_CLASS_POINTER_DEFINITION(PressureCond3D); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - PressureCond3D(IndexType NewId, GeometryType::Pointer pGeometry); - PressureCond3D(IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties); - - /// Destructor. - virtual ~PressureCond3D(); - - - ///@} - ///@name Operators - ///@{ - - - ///@} - ///@name Operations - ///@{ - - Condition::Pointer Create(IndexType NewId, NodesArrayType const& ThisNodes, PropertiesType::Pointer pProperties) const; - - void CalculateLocalSystem(MatrixType& rLeftHandSideMatrix, VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo); - - void CalculateRightHandSide(VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo); - //virtual void CalculateLeftHandSide(MatrixType& rLeftHandSideMatrix, ProcessInfo& rCurrentProcessInfo); - - void EquationIdVector(EquationIdVectorType& rResult, ProcessInfo& rCurrentProcessInfo); - - void GetDofList(DofsVectorType& ConditionalDofList,ProcessInfo& CurrentProcessInfo); - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. -// virtual String Info() const; - - /// Print information about this object. -// virtual void PrintInfo(std::ostream& rOStream) const; - - /// Print object's data. -// virtual void PrintData(std::ostream& rOStream) const; - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - - - - ///@} - ///@name Private Operators - ///@{ - - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - //PressureCond3D& operator=(const PressureCond3D& rOther); - - /// Copy constructor. - //PressureCond3D(const PressureCond3D& rOther); - - - ///@} - -}; // Class PressureCond3D - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -/* inline std::istream& operator >> (std::istream& rIStream, - PressureCond3D& rThis); -*/ -/// output stream function -/* inline std::ostream& operator << (std::ostream& rOStream, - const PressureCond3D& rThis) - { - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; - }*/ -///@} - -} // namespace Kratos. - -#endif // KRATOS_PRESSURE_CONDITION3D_H_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_elements/updated_lagrangian_fluid.cpp b/applications/PFEMapplication/custom_elements/updated_lagrangian_fluid.cpp deleted file mode 100755 index 0709174b2ce9..000000000000 --- a/applications/PFEMapplication/custom_elements/updated_lagrangian_fluid.cpp +++ /dev/null @@ -1,921 +0,0 @@ -// -// Project Name: Kratos -// Last modified by: $Author: rrossi $ -// Date: $Date: 2007-01-23 15:38:00 $ -// Revision: $Revision: 1.1 $ -// -// -//this is an element for 3D - -// System includes - - -// External includes - - -// Project includes -#include "includes/define.h" -#include "custom_elements/updated_lagrangian_fluid.h" -#include "utilities/math_utils.h" - -//#include "constitutive_laws/constitutive_laws.h" -//#include "constitutive_laws/isotropic_planestress_wrinkling_new.h" -#include "PFEM_application.h" - -namespace Kratos -{ -Matrix UpdatedLagrangianFluid::msB(0,0); -Matrix UpdatedLagrangianFluid::msF(0,0); -Matrix UpdatedLagrangianFluid::msD(0,0); -Matrix UpdatedLagrangianFluid::msC(0,0); -Matrix UpdatedLagrangianFluid::msCapx(0,0); - -Vector UpdatedLagrangianFluid::msStrainVector(0); -Vector UpdatedLagrangianFluid::msStressVector(0); - -Matrix UpdatedLagrangianFluid::msDN_DX(0,0); - -//************************************************************************************ -//************************************************************************************ -UpdatedLagrangianFluid::UpdatedLagrangianFluid(IndexType NewId, GeometryType::Pointer pGeometry) - : Element(NewId, pGeometry) -{ - //DO NOT ADD DOFS HERE!!! -} - -//************************************************************************************ -//************************************************************************************ -UpdatedLagrangianFluid::UpdatedLagrangianFluid(IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) - : Element(NewId, pGeometry, pProperties) -{ - unsigned int dim = GetGeometry().WorkingSpaceDimension(); - - mpReferenceGeometry = GetGeometry().Clone(); - - //setting up the nodal degrees of freedom - for(unsigned int i = 0 ; i != GetGeometry().size() ; ++i) - { - (GetGeometry()[i].pAddDof(DISPLACEMENT_X,REACTION_X)); - (GetGeometry()[i].pAddDof(DISPLACEMENT_Y,REACTION_Y)); - if(dim == 3) - (GetGeometry()[i].pAddDof(DISPLACEMENT_Z,REACTION_Z)); - } - - //initializing static variables - unsigned int dimension = GetGeometry().WorkingSpaceDimension(); - unsigned int dim2 = GetGeometry().size()*dimension; - unsigned int StrainSize; - if (dimension==2) - StrainSize = 3; - else - StrainSize = 6; - msB.resize(StrainSize,dim2); - msF.resize(dimension,dimension); - msD.resize(StrainSize,StrainSize); - msC.resize(dimension,dimension); - msCapx.resize(StrainSize,StrainSize); - msStrainVector.resize(StrainSize); - msStressVector.resize(StrainSize); - msDN_DX.resize(GetGeometry().size(),dimension); -} - -Element::Pointer UpdatedLagrangianFluid::Create(IndexType NewId, NodesArrayType const& ThisNodes, PropertiesType::Pointer pProperties) const -{ - return Element::Pointer(new UpdatedLagrangianFluid(NewId, GetGeometry().Create(ThisNodes), pProperties)); -} - -UpdatedLagrangianFluid::~UpdatedLagrangianFluid() -{ -} -//************************************************************************************ -//************************************************************************************ -void UpdatedLagrangianFluid::InitializeSolutionStep(ProcessInfo &CurrentProcessInfo) -{ - KRATOS_TRY - - //calculating the values of Jacobian at the integration points - //JACOBIAN IS CONST FOR A LINEAR ELEMENT - const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints(); - - //resizing jacobian inverses containers - mInvJ0.resize(integration_points.size()); - mDetJ0.resize(integration_points.size()); - - GeometryType::JacobiansType J0; - J0 = GetGeometry().Jacobian(J0); - mTotalDomainInitialSize = 0.00; - - //calculating the inverse J0 - for(unsigned int PointNumber = 0; PointNumber::InvertMatrix(J0[PointNumber],mInvJ0[PointNumber],mDetJ0[PointNumber]); - //calculating the total area - mTotalDomainInitialSize += mDetJ0[PointNumber]*IntegrationWeight; - } - KRATOS_CATCH("") -} - -//************************************************************************************ -//************************************************************************************ -void UpdatedLagrangianFluid::CalculateAll(MatrixType& rLeftHandSideMatrix, VectorType& rRightHandSideVector, - ProcessInfo& rCurrentProcessInfo, - bool CalculateStiffnessMatrixFlag, - bool CalculateResidualVectorFlag) -{ - KRATOS_TRY - - unsigned int number_of_nodes = GetGeometry().size(); - unsigned int dim = GetGeometry().WorkingSpaceDimension(); - //resizing as needed the LHS - //e.g. in 2D and using linear triangles => MatSize = 3*2=6 - unsigned int MatSize=number_of_nodes*dim; - - if (CalculateStiffnessMatrixFlag == true) //calculation of the matrix is required - { - if(rLeftHandSideMatrix.size1() != MatSize) - rLeftHandSideMatrix.resize(MatSize,MatSize); - noalias(rLeftHandSideMatrix) = ZeroMatrix(MatSize,MatSize); //resetting LHS - } - - //resizing as needed the RHS - if (CalculateResidualVectorFlag == true) //calculation of the matrix is required - { - if(rRightHandSideVector.size() != MatSize) - rRightHandSideVector.resize(MatSize); - rRightHandSideVector = ZeroVector(MatSize); //resetting RHS - } - //reading integration points and local gradients - const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints(); - const GeometryType::ShapeFunctionsGradientsType& DN_De = GetGeometry().ShapeFunctionsLocalGradients(); - const Matrix& Ncontainer = GetGeometry().ShapeFunctionsValues(); - - //calculating actual jacobian - GeometryType::JacobiansType J; - GetGeometry().Jacobian(J); - - double dd=0.0; - Matrix Jinvv (2,2); - - MathUtils::InvertMatrix(J[0],Jinvv,dd); - - if (dd<=0.0) - { - std::cout<<"ERROR........ negative det"<WorkingSpaceDimension(); - double weight = GaussPointWeight; - - weight *= DetJ0; - //if (dimension == 2) weight *= GetProperties()[THICKNESS]; - if (dimension == 2) weight *= 1; - return weight; -} - -////************************************************************************************ -////************************************************************************************ -void UpdatedLagrangianFluid::FinalizeSolutionStep(ProcessInfo& CurrentProcessInfo) -{ - /* for(unsigned int i = 0; i < mConstitutiveLawVector.size(); i++) - mConstitutiveLawVector[i]->FinalizeSolutionStep(CurrentProcessInfo);*/ -} -//************************************************************************************ -//************************************************************************************ -inline void UpdatedLagrangianFluid::CalculateAndAdd_ExtForceContribution( - const Vector& N, - const ProcessInfo& CurrentProcessInfo, - Vector& BodyForce, - VectorType& rRightHandSideVector, - double weight -) -{ - KRATOS_TRY - unsigned int number_of_nodes = mpReferenceGeometry->PointsNumber(); - unsigned int dimension = mpReferenceGeometry->WorkingSpaceDimension(); - - for (unsigned int i=0; i::InvertMatrix(J[0],Jinvv,dd); - - if (dd<=0.0) - { - for (unsigned int i=0; iWorkingSpaceDimension(); - Matrix StressTensor (dim,dim); - Matrix PK2 (dim, dim); - Matrix VelGrad (dim, dim); - Matrix invF(dim, dim); - Matrix invTransF(dim, dim); - - Matrix aux(dim,dim+1); - //calculating viscosity and density - double nu = GetProperties()[VISCOSITY]; - double ro = GetProperties()[DENSITY]; - //calculating velocity gradient - for(unsigned int iii = 0; iii < GetGeometry().size(); iii++) - { - const array_1d& v = GetGeometry()[iii].FastGetSolutionStepValue(VELOCITY); - for(unsigned int j=0; j ::InvertMatrix(F,invF,detF); - - Matrix temp = prod ( StressTensor, trans(invF )); - noalias(PK2) = detF * prod( invF , temp ); - //now we apply Voigt rule: - //and add the volumetric part - resulting from the trace of G-L strain tensor - //std::cout<<" STRESS VEC " <::InvertMatrix(F,invF,detF); - MathUtils::InvertMatrix(trans(F),invTransF,detTransF); - - PK2 = prod( invF , prod ( StressTensor, invTransF ) ); - PK2 *= detF;*/ - - //now we apply Voigt rule: - StressVector[0] = PK2(0,0); - StressVector[1] = PK2(1,1); - StressVector[2] = PK2(2,2); - StressVector[3] = PK2(1,2); - StressVector[4] = PK2(0,2); - StressVector[5] = PK2(0,1); - } - KRATOS_CATCH("") -} - - -void UpdatedLagrangianFluid::CalculateAndAddKg( - MatrixType& K, - Matrix& DN_DX, - Vector& StressVector, - double weight) -{ - KRATOS_TRY - unsigned int dimension = GetGeometry().WorkingSpaceDimension(); - Matrix StressTensor = MathUtils::StressVectorToTensor(StressVector); - Matrix ReducedKg = prod(DN_DX, weight * Matrix(prod(StressTensor,trans(DN_DX)) ) ); //to be optimized - MathUtils::ExpandAndAddReducedMatrix(K,ReducedKg,dimension); - //std::cout<<"Kg "<WorkingSpaceDimension(); - - if (dimension==2) - { - if(StrainVector.size() != 3) StrainVector.resize(3); - StrainVector[0] = 0.5*(C(0,0) - 1.00); - StrainVector[1] = 0.5*(C(1,1) - 1.00); - StrainVector[2] = C(0,1); - } - if (dimension==3) - { - if(StrainVector.size() != 6) StrainVector.resize(6); - StrainVector[0] = 0.5*(C(0,0) - 1.00); - StrainVector[1] = 0.5*(C(1,1) - 1.00); - StrainVector[2] = 0.5*(C(2,2) - 1.00); - StrainVector[3] = C(0,1); - StrainVector[4] = C(1,2); - StrainVector[5] = C(0,2); - } - KRATOS_CATCH("") -} -//************************************************************************************ -//************************************************************************************ -void UpdatedLagrangianFluid::CalculateB( - Matrix& B, - Matrix& F, - Matrix& DN_DX, - unsigned int StrainSize) -{ - KRATOS_TRY - const unsigned int number_of_nodes = mpReferenceGeometry->PointsNumber(); - unsigned int dimension = mpReferenceGeometry->WorkingSpaceDimension(); - // - //unsigned int dim2 = number_of_nodes*dimension; - //if(B.size1() != StrainSize || B.size2()!=dim2) - // B.resize(StrainSize,dim2); - //Matrix Bi; - for (unsigned int i=0; i::WriteMatrix(B,Bi,0,index); - } - KRATOS_CATCH("") -} - -//************************************************************************************ -//************************************************************************************ -void UpdatedLagrangianFluid::EquationIdVector(EquationIdVectorType& rResult, ProcessInfo& CurrentProcessInfo) -{ - int number_of_nodes = GetGeometry().size(); - int dim = GetGeometry().WorkingSpaceDimension(); - unsigned int dim2 = number_of_nodes*dim; - if(rResult.size() != dim2) - rResult.resize(dim2); - - for (int i=0; i& rVariable, std::vector< Matrix >& Output, const ProcessInfo& rCurrentProcessInfo) -{ - //unsigned int number_of_nodes = GetGeometry().size(); - unsigned int dim = GetGeometry().WorkingSpaceDimension(); - - //resizing as needed the LHS - //unsigned int MatSize=number_of_nodes*dim; - - //reading integration points and local gradients - const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints(); - //const Matrix& Ncontainer = mpReferenceGeometry->ShapeFunctionsValues(); - - //calculating actual jacobian - GeometryType::JacobiansType J; - J = GetGeometry().Jacobian(J); - - //auxiliary terms - Matrix F(dim,dim); - Matrix C(dim,dim); - Vector StrainVector; - Vector StressVector; - - if(Output.size() != integration_points.size()) - Output.resize(integration_points.size()); - - for(unsigned int PointNumber = 0; PointNumberUpdateMaterial(StrainVector,rCurrentProcessInfo); - // StressVector = mConstitutiveLawVector[PointNumber]->CalculateStress(StrainVector); //saving the stress vector - - for(unsigned int ii = 0; ii >& rVariable, array_1d& Output, const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_TRY - - unsigned int number_of_nodes = GetGeometry().size(); - unsigned int dim = GetGeometry().WorkingSpaceDimension(); - - //resizing as needed the LHS - //e.g. in 2D and using linear triangles => MatSize = 3*2=6 - unsigned int MatSize=number_of_nodes*dim; - - Vector aaa(MatSize); - - - //reading integration points and local gradients - const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints(); - const GeometryType::ShapeFunctionsGradientsType& DN_De = GetGeometry().ShapeFunctionsLocalGradients(); - //const Matrix& Ncontainer = GetGeometry().ShapeFunctionsValues(); - - //calculating actual jacobian - GeometryType::JacobiansType J; - GetGeometry().Jacobian(J); - - for(unsigned int PointNumber = 0; PointNumber::InvertMatrix(J[0],Jinvv,dd); - - //and now we store the pressure forces on the nodes - for(unsigned int inode = 0; inode& tmp = GetGeometry()[inode].FastGetSolutionStepValue(PRESSURE_FORCE); - for(unsigned k=0; k& rVariable, std::vector< Matrix >& Output, const ProcessInfo& rCurrentProcessInfo); - //void Calculate(array_1d& rVariable, array_1d& Output, const ProcessInfo& rCurrentProcessInfo); - void Calculate(const Variable< array_1d >& rVariable, array_1d& Output, const ProcessInfo& rCurrentProcessInfo); - //void Calculate(const Variable& rVariable, double& Output, const ProcessInfo& rCurrentProcessInfo); - - void GetValuesVector(Vector& values, int Step = 0); - void GetFirstDerivativesVector(Vector& values, int Step = 0); - void GetSecondDerivativesVector(Vector& values, int Step = 0); - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. -// virtual String Info() const; - - /// Print information about this object. -// virtual void PrintInfo(std::ostream& rOStream) const; - - /// Print object's data. -// virtual void PrintData(std::ostream& rOStream) const; - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - static Matrix msB; - static Matrix msF; - static Matrix msD; - static Matrix msC; - //approximate constitutive tensor - static Matrix msCapx; - static Vector msStrainVector; - static Vector msStressVector; - - static Matrix msDN_DX; - - ///@} - ///@name Member Variables - ///@{ - - // std::vector mConstitutiveLawVector; - - Geometry< Point<3,double> >::Pointer mpReferenceGeometry; - - double mTotalDomainInitialSize; - std::vector< Matrix > mInvJ0; - Vector mDetJ0; - - - ///@} - ///@name Private Operators - ///@{ - /** K += weight*Btrans*D*B */ - - //this function computes the Cauchy stress in the fluid which will - //consist of the "shear part" (velocity grads) and the volumetric part - //and then transforms the Cauchy tensor into PK2 stress tensor - //then using Voigt rule we store PK2 stress as a vector - void CalculateIncPK2Stress(double& BulkModulus, Vector& StressVector, Matrix& F); - - void CalculateAll(MatrixType& rLeftHandSideMatrix, VectorType& rRightHandSideVector, - ProcessInfo& rCurrentProcessInfo, - bool CalculateStiffnessMatrixFlag, - bool CalculateResidualVectorFlag); - - void CalculateAndAddKm( - MatrixType& K, - Matrix& B, - Matrix& D, - double weight); - - /** Calculation of the Geometric Stiffness Matrix. Kg = dB * S*/ - void CalculateAndAddKg( - MatrixType& K, - Matrix& DN_DX, - Vector& StressVector, - double weight - ); - - - - - void CalculateBodyForces( - Vector& BodyForce, - const ProcessInfo& CurrentProcessInfo - ); - - - void InitializeVariables(); - - double CalculateIntegrationWeight - (double GaussPointWeight, - double DetJ0); - - void CalculateAndAdd_ExtForceContribution( - const Vector& N, - const ProcessInfo& CurrentProcessInfo, - Vector& BodyForce, - VectorType& mResidualVector, - double weight - ); - - void CalculateStrain(const Matrix& C, - Vector& StrainVector); - - void CalculateB( Matrix& B, - Matrix& F, - Matrix& DN_DX, - unsigned int StrainSize); - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - //UpdatedLagrangianFluid& operator=(const UpdatedLagrangianFluid& rOther); - - /// Copy constructor. - //UpdatedLagrangianFluid(const UpdatedLagrangianFluid& rOther); - - - ///@} - -}; // Class UpdatedLagrangianFluid - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -/* inline std::istream& operator >> (std::istream& rIStream, - UpdatedLagrangianFluid& rThis); -*/ -/// output stream function -/* inline std::ostream& operator << (std::ostream& rOStream, - const UpdatedLagrangianFluid& rThis) - { - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; - }*/ -///@} - -} // namespace Kratos. - -#endif // KRATOS_UPDATED_LAGRANGIAN_FLUID_H_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_erosion_fluid b/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_erosion_fluid deleted file mode 100755 index b35df681eecc..000000000000 --- a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_erosion_fluid +++ /dev/null @@ -1,94 +0,0 @@ -PROBLEMTYPE pfem_erosion # The name of your problemtype -USE KRATOS DEFINITIONS # Use default definition for this problemtype... -USE PYTHON SCRIPTS pfem_erosion_scripts # ... but include my scripts from this folder - -VECTOR CONDITION DISPLACEMENT point line surface volume fixed 0.0 0.0 0.0 -VECTOR CONDITION VELOCITY point line surface volume fixed 0.0 0.0 0.0 -VECTOR CONDITION MESH_VELOCITY point line surface volume free 0.0 0.0 0.0 -#VECTOR CONDITION BODY_FORCE point line surface volume free 0.0 0.0 0.0 -SCALAR CONDITION PRESSURE point line surface volume free 0.0 -SCALAR CONDITION WATER_PRESSURE point line surface volume free 0.0 -#SCALAR CONDITION POROSITY point line surface volume free 1.0 -SCALAR CONDITION EXTERNAL_PRESSURE point line surface volume free 0.0 -#SCALAR CONDITION VISCOSITY point line surface volume free 0.000001 -#SCALAR CONDITION DENSITY point line surface volume free 1.0 - -FLAG CONDITION IS_INTERFACE point line surface volume free 1.0 -FLAG CONDITION FLAG_VARIABLE point line surface volume free 1.0 2.0 3.0 4.0 5.0 -FLAG CONDITION IS_BOUNDARY point line surface volume free 1.0 2.0 3.0 4.0 5.0 -FLAG CONDITION IS_FREE_SURFACE point line surface volume free 1.0 0.0 -FLAG CONDITION IS_EROSIONABLE point line surface volume free 1.0 0.0 -FLAG CONDITION IS_STRUCTURE point line surface volume free 1.0 0.0 - -FACE CONDITION Condition2D line -FACE CONDITION Condition3D surface -FACE CONDITION Fluid2DNeumann line -FACE CONDITION Fluid3DNeumann surface - -ELEMENT Fluid2D surface -ELEMENT ASGS2D surface -ELEMENT Fluid3D volume -ELEMENT ASGS3D volume -ELEMENT Fluid2DCoupled surface -ELEMENT Fluid3DCoupled volume - -PROPERTY Density 1000.0 Density -PROPERTY Viscosity 0.000001 Viscosity -PROPERTY Gravity_X 0.0 Gravity_X -PROPERTY Gravity_Y -9.806 Gravity_Y -PROPERTY Gravity_Z 0.0 Gravity_Z -PROPERTY Porosity 1.0 Porosity -PROPERTY Diameter 0.01 Diameter -PROPERTY fixed_dam 0.0 fixed_dam - -PROPERTY max_time 100.0 max_time -PROPERTY max_x 10.0 max_x -PROPERTY max_y 10.0 max_y -PROPERTY max_z 10.0 max_z -PROPERTY min_x -1.0 min_x -PROPERTY min_y -1.0 min_y -PROPERTY min_z -1.0 min_z -PROPERTY use_oss 0 use_oss -PROPERTY dynamic_tau 1 dynamic_tau -PROPERTY nsteps 100 nsteps -PROPERTY output_dt 0.1 output_Dt -PROPERTY min_dt 0.001 min_dt -PROPERTY max_dt 0.1 max_dt -PROPERTY safety_factor 0.5 safety_factor - -TEXT FLAG PROPERTY SolverType pfem_solver_ale monolithic_solver_lagrangian SolverType # remember to put the text between " " ! -PROPERTY laplacian_form 3 laplacian_form - -FILE SELECTION fluid_file fluid.mdpa fluid_file - -DEFINE MODEL PART WallBoundary point line surface LOWER -ADD CONDITION VELOCITY point line surface volume fixed 0.0 0.0 0.0 -ADD CONDITION DISPLACEMENT point line surface volume fixed 0.0 0.0 0.0 -ADD CONDITION IS_STRUCTURE point line surface volume free 1.0 - -DEFINE MODEL PART FreeSurfaceBoundary point line surface LOWER -ADD CONDITION IS_FREE_SURFACE point line surface volume free 1.0 - -DEFINE BOUNDARY PART Boundary OUTWARDS NORMALS -ADD 2D ELEMENT Condition2D -ADD 3D ELEMENT Condition3D -ADD 2D CONDITION IS_BOUNDARY point line surface 1.0 - -#DEFINE ALL ENTITIES PART All_volumes volume -#ADD 3D ELEMENT Fluid3D - -# Part Interaction --> considering all of the combinations!!! -GROUP WallBoundary FreeSurfaceBoundary IN point line surface -WallBoundary FreeSurfaceBoundary ASSIGN VELOCITY fixed 0.0 0.0 0.0 DISPLACEMENT fixed 0.0 0.0 0.0 IS_STRUCTURE free 1.0 -# WallBoundary FreeSurfaceBoundary ASSIGN DISPLACEMENT fixed 0.0 0.0 0.0 -# WallBoundary FreeSurfaceBoundary ASSIGN IS_STRUCTURE free 1.0 - - - - - - - - - - diff --git a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_erosion_scripts/script.py b/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_erosion_scripts/script.py deleted file mode 100755 index f05f87e6ac6c..000000000000 --- a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_erosion_scripts/script.py +++ /dev/null @@ -1,419 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# import the configuration data as read from the GiD -import problem_settings -import time -# -# -# setting the domain size for the problem to be solved -domain_size = pfem_erosion_var.domain_size - -# read from pfem_erosion_var name and path of fluid_gid_problem -# Acuario version********************************* -# fluid_path='/home/antonia/EXAMPLES/Erosion/WorkingErosCFixed.gid/' - - -fluid_path = pfem_erosion_var.fluid_file.rpartition('/') -fluid_path = fluid_path[0] - -# -# -# ATTENTION: here the order is important - -# including kratos path -import sys -sys.path.append(pfem_erosion_var.kratos_path) - -# importing Kratos main library -from KratosMultiphysics import * - -from KratosMultiphysics.StructuralApplication import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * -from KratosMultiphysics.ExternalSolversApplication import* - - -# from now on the order is not anymore crucial -# -# -import math -import edgebased_levelset_var -import edgebased_levelset_solver - -# import cProfile - -# defining the two model part: pfem_model_part and fixed_model_part -pfem_model_part = ModelPart("PfemFluidPart") -fixed_model_part = ModelPart("FixedFluidPart") - -# importing the fluid_solver files and adding the variablesv -edgebased_levelset_solver.AddVariables(fixed_model_part) -fixed_model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) -fixed_model_part.AddNodalSolutionStepVariable(POROSITY) -fixed_model_part.AddNodalSolutionStepVariable(DIAMETER) -fixed_model_part.AddNodalSolutionStepVariable(SEEPAGE_DRAG) -# fixed_model_part.AddNodalSolutionStepVariable(VISCOSITY) - -# importing the structural_solver files and adding the variables -SolverType = pfem_erosion_var.SolverType -if(SolverType == "pfem_solver_ale"): - print("Pfem_solver_ale_not supported. Check to be using asgs2d element") - import pfem_solver_ale_antonia - pfem_solver_ale_antonia.AddVariables(pfem_model_part) - pfem_model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) - pfem_model_part.AddNodalSolutionStepVariable(IS_VISITED) - pfem_model_part.AddNodalSolutionStepVariable(IS_EROSIONABLE) - pfem_model_part.AddNodalSolutionStepVariable(FRICTION_COEFFICIENT) - pfem_model_part.AddNodalSolutionStepVariable(POROSITY) - pfem_model_part.AddNodalSolutionStepVariable(DIAMETER) - pfem_model_part.AddNodalSolutionStepVariable(SEEPAGE_DRAG) -elif(SolverType == "monolithic_solver_lagrangian"): - import monolithic_solver_lagrangian - monolithic_solver_lagrangian.AddVariables(pfem_model_part) - pfem_model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) - pfem_model_part.AddNodalSolutionStepVariable(IS_VISITED) - pfem_model_part.AddNodalSolutionStepVariable(IS_EROSIONABLE) - pfem_model_part.AddNodalSolutionStepVariable(FRICTION_COEFFICIENT) - pfem_model_part.AddNodalSolutionStepVariable(POROSITY) - pfem_model_part.AddNodalSolutionStepVariable(NODAL_MASS) - pfem_model_part.AddNodalSolutionStepVariable(DIAMETER) - pfem_model_part.AddNodalSolutionStepVariable(SEEPAGE_DRAG) -else: - raise "solver type not supported: options are FractionalStep - Monolithic" - - -# reading the models -name_pfem = pfem_erosion_var.problem_name -name_fixed = pfem_erosion_var.fluid_file - - -gid_mode = GiDPostMode.GiD_PostBinary -multifile = MultiFileFlag.MultipleFiles -deformed_mesh_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteElementsOnly - -# READING FROM MULTIPLE .gid FILES######################## -# reading the pfem model part -gid_io = EdgebasedGidIO(name_pfem, gid_mode, multifile, deformed_mesh_flag, write_conditions) -model_part_io_structure = ModelPartIO(name_pfem) -model_part_io_structure.ReadModelPart(pfem_model_part) -print("pfem model read correctly") -# reading the fixed model part with the new porblem type format -model_part_io_fluid = ModelPartIO(name_fixed) -model_part_io_fluid.ReadModelPart(fixed_model_part) -print("fixed model read correctly") - -# NODAL CONDITIONS of the PFEM model -for node in pfem_model_part.Nodes: - node.SetSolutionStepValue(DENSITY, 0, pfem_erosion_var.Density) - node.SetSolutionStepValue(VISCOSITY, 0, pfem_erosion_var.Viscosity) - node.SetSolutionStepValue(POROSITY, 0, pfem_erosion_var.Porosity) - node.SetSolutionStepValue(DIAMETER, 0, pfem_erosion_var.Diameter) - node.SetSolutionStepValue(BODY_FORCE_X, 0, pfem_erosion_var.Gravity_X) - node.SetSolutionStepValue(BODY_FORCE_Y, 0, pfem_erosion_var.Gravity_Y) - node.SetSolutionStepValue(BODY_FORCE_Z, 0, pfem_erosion_var.Gravity_Z) - node.SetSolutionStepValue(FRICTION_COEFFICIENT, 0, 0.0) - - -edgebased_levelset_solver.AddDofs(fixed_model_part) - -# NODAL CONDITIONS of the FIXED model -# we assume here that all of the internal nodes are marked with a negative distance -# set the distance of all of the internal nodes to a small value -small_value = 0.0001 -n_active = 0 -for node in fixed_model_part.Nodes: - dist = node.GetSolutionStepValue(DISTANCE) - if(dist < 0.0): - n_active = n_active + 1 - node.SetSolutionStepValue(DISTANCE, 0, -small_value) - else: - node.SetSolutionStepValue(DISTANCE, 0, small_value) - -if(n_active == 0): - raise "ERROR. At least one node has to be initialized with a distance lesser than 0" - -# make sure that the porosity is not zero on any node (set by default to fluid only) -for node in fixed_model_part.Nodes: - if(node.GetSolutionStepValue(POROSITY) == 0.0): - node.SetSolutionStepValue(POROSITY, 0, 1.0) - if(node.GetSolutionStepValue(DIAMETER) == 0.0): - node.SetSolutionStepValue(DIAMETER, 0, 1.0) - -# print pfem_model_part -# print pfem_model_part.Properties - -# setting the limits of the bounding box -box_corner1 = Vector(3) -box_corner1[0] = pfem_erosion_var.min_x -box_corner1[1] = pfem_erosion_var.min_y -box_corner1[2] = pfem_erosion_var.min_z -box_corner2 = Vector(3) -box_corner2[0] = pfem_erosion_var.max_x -box_corner2[1] = pfem_erosion_var.max_y; -box_corner2[2] = pfem_erosion_var.max_z; - -# time setting -output_dt = pfem_erosion_var.output_Dt -max_dt = pfem_erosion_var.max_dt -min_dt = pfem_erosion_var.min_dt -safety_factor = pfem_erosion_var.safety_factor -nsteps = pfem_erosion_var.nsteps - -# the buffer size should be set up here after the mesh is read for the first time -pfem_model_part.SetBufferSize(2) -fixed_model_part.SetBufferSize(2) - - -# constructing the fluid_solver (FIXED) -body_force = Vector(3) -body_force[0] = pfem_erosion_var.Gravity_X -body_force[1] = pfem_erosion_var.Gravity_Y -body_force[2] = pfem_erosion_var.Gravity_Z - -viscosity = edgebased_levelset_var.viscosity -# print "***************** VISCOSITY *********************" -# print viscosity -density = edgebased_levelset_var.density -# print "***************** DENSITY *********************" -# print density -fluid_solver = edgebased_levelset_solver.EdgeBasedLevelSetSolver(fixed_model_part, domain_size, body_force, viscosity, density) - -fluid_solver.redistance_frequency = edgebased_levelset_var.redistance_frequency -fluid_solver.extrapolation_layers = edgebased_levelset_var.extrapolation_layers -fluid_solver.stabdt_pressure_factor = edgebased_levelset_var.stabdt_pressure_factor -fluid_solver.stabdt_convection_factor = edgebased_levelset_var.stabdt_convection_factor -fluid_solver.tau2_factor = edgebased_levelset_var.tau2_factor -fluid_solver.edge_detection_angle = edgebased_levelset_var.edge_detection_angle -fluid_solver.assume_constant_pressure = edgebased_levelset_var.assume_constant_pressure - -fluid_solver.Initialize() - -if(edgebased_levelset_var.wall_law_y > 1e-10): - fluid_solver.fluid_solver.ActivateWallResistance(edgebased_levelset_var.wall_law_y); - -# - -if(SolverType == "pfem_solver_ale"): - # adding dofs - print("pfem_solver_ale is being used whereas with erosion module only monolithic solver lagrangian is allowed. Check also to be using use asgs2d!!") -elif(SolverType == "monolithic_solver_lagrangian"): - # adding dofs - monolithic_solver_lagrangian.AddDofs(pfem_model_part) - structural_solver = monolithic_solver_lagrangian.MonolithicSolver(pfem_model_part, domain_size, box_corner1, box_corner2) - oss_swith = pfem_erosion_var.use_oss - dynamic_tau = pfem_erosion_var.dynamic_tau - pfem_model_part.ProcessInfo.SetValue(OSS_SWITCH, oss_swith); - pfem_model_part.ProcessInfo.SetValue(DYNAMIC_TAU, dynamic_tau); - # structural_solver.linear_solver = SuperLUSolver() - structural_solver.Initialize(output_dt) - - -if (domain_size == 3): - ProjectionModule = MeshTransfer3D(); - ErosionModule = ErosionUtils3D(); -else: - ProjectionModule = MeshTransfer2D(); - ErosionModule = ErosionUtils2D(); -PfemUtils = PfemUtils(); -DragUtils = DragUtils(); - -# To be inserted in the problem type######## -critical_vel = Vector(3); -critical_vel[0] = 0.06; -critical_vel[1] = 0.0; -critical_vel[2] = 0.0; -critical_en = 0.000001; -# - -ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, POROSITY, POROSITY); -ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, DIAMETER, DIAMETER); -# bool to decide to solve or not the pfem model -calculate_dam = False - -# settings to be changed edgebased FIXED -max_Dt = edgebased_levelset_var.max_time_step -initial_Dt_ls = 0.001 * max_Dt -final_time = edgebased_levelset_var.max_time -safety_factor = edgebased_levelset_var.safety_factor - -number_of_inital_steps = edgebased_levelset_var.number_of_inital_steps -initial_time_step = edgebased_levelset_var.initial_time_step -out = 0 - -original_max_dt = max_Dt -Time = 0.0 -step = 0 -next_output_time = output_dt -max_safety_factor = safety_factor - -substep_number = 10 -substep_counter = 0 - -while(Time < final_time): -# print "line49" - - if(step < number_of_inital_steps): - max_Dt = initial_time_step - else: - max_Dt = original_max_dt - # progressively increment the safety factor - # in the steps that follow a reduction of it - safety_factor = safety_factor * 1.2 - if(safety_factor > max_safety_factor): - safety_factor = max_safety_factor - - Dt = fluid_solver.EstimateTimeStep(safety_factor, max_Dt) - - Time = Time + Dt - fixed_model_part.CloneTimeStep(Time) - - # let's do this later ... only each substep_number fluid solutions - # pfem_model_part.CloneTimeStep(Time) - - print("******** CURRENT TIME = ", Time) - - if(step > 3): - if(calculate_dam): - ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, POROSITY, POROSITY); - ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, DIAMETER, DIAMETER); - - for node in fixed_model_part.Nodes: - if(node.GetSolutionStepValue(POROSITY) == 0.0): - node.SetSolutionStepValue(POROSITY, 0, 1.0) - if(node.GetSolutionStepValue(DIAMETER) == 0.0): - node.SetSolutionStepValue(DIAMETER, 0, 1.0) - - # solving the fluid problem ........................................................................................... - print("starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~") - fluid_solver.Solve(); - print("finished solving fluid edgebased") - - print("start checking the time stepping") - check_dt = fluid_solver.EstimateTimeStep(0.95, max_Dt) - - if(check_dt < Dt): - print("***********************************************************") - print("***********************************************************") - print("***********************************************************") - print(" *** REDUCING THE TIME STEP ***") - print("***********************************************************") - print("***********************************************************") - print("***********************************************************") - - # we found a velocity too large! we need to reduce the time step - fluid_solver.fluid_solver.ReduceTimeStep(fixed_model_part, Time) # this is to set the database to the value at the beginning of the step - - safety_factor *= edgebased_levelset_var.reduction_on_failure - reduced_dt = fluid_solver.EstimateTimeStep(safety_factor, max_Dt) - - print("time before reduction= ", Time) - Time = Time - Dt + reduced_dt - print("reduced time = ", Time) - print("Dt = ", Dt) - print("reduced_dt = ", reduced_dt) - - fluid_solver.fluid_solver.ReduceTimeStep(fixed_model_part, Time) # this is to set the database to the value at the beginning of the step - fluid_solver.Solve() - print("finished checking the time stepping") - print(fixed_model_part) - - if(substep_counter == substep_number): - substep_counter = 0 - - pfem_model_part.CloneTimeStep(Time) - - print(pfem_model_part) - # solving the structural problem ........................................................................................... - print("starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~") - PfemUtils.CalculateNodalMass(pfem_model_part, domain_size) - print("starting EROSION") - structural_solver.neigh_finder.Execute(); - print("founded neighbours") - calculate_dam = ErosionModule.CheckErosionableNodes(fixed_model_part, pfem_model_part, critical_vel, critical_en, viscosity, density); - print("finished EROSION") - - if(calculate_dam): - - # Adding Darcy non linear term to the external forces - DragUtils.CalculateFluidDrag(fixed_model_part, SEEPAGE_DRAG, viscosity) - ProjectionModule.DirectVectorialVarInterpolation(fixed_model_part, pfem_model_part, SEEPAGE_DRAG, SEEPAGE_DRAG); - DragUtils.AddDrag(pfem_model_part, SEEPAGE_DRAG, BODY_FORCE, body_force) - - # PFEM steps - structural_solver.Remesh(); - print("Remesh in done!") - (structural_solver.solver).Solve(); - print("Solve in done!") - (structural_solver.solver).Clear(); - - print("finished solving structure") - # ErosionModule.SetErosionableNodes(pfem_model_part); - # if (Time>0.25): - # ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, POROSITY); - # for node in fixed_model_part.Nodes: - # if( node.GetSolutionStepValue(POROSITY) == 0.5): - # print node.Id - - if (Time > 9.0): - substep_number = 2 - substep_counter += 1 - -# - if(Time >= next_output_time): - # a change in the output name is needed!!!! - - res_name1 = str(name_fixed) - gid_io.ChangeOutputName(res_name1) - gid_io.InitializeMesh(Time); - gid_io.WriteMesh(fixed_model_part.GetMesh()) - gid_io.FinalizeMesh(); - gid_io.InitializeResults(Time, fixed_model_part.GetMesh()) -# print "structure output ****************************************************" - gid_io.WriteNodalResults(VELOCITY, fixed_model_part.Nodes, Time, 0) -# gid_io.WriteNodalResults(CONV_VELOCITY,fixed_model_part.Nodes,Time,0) - gid_io.WriteNodalResults(PRESSURE, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DISTANCE, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(PRESS_PROJ, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(POROSITY, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DIAMETER, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(SEEPAGE_DRAG, fixed_model_part.Nodes, Time, 0) - - gid_io.Flush() - gid_io.FinalizeResults() - - res_name2 = str(name_pfem) - gid_io.ChangeOutputName(res_name2) - gid_io.InitializeMesh(Time); - gid_io.WriteNodeMesh(pfem_model_part.GetMesh()); - gid_io.WriteMesh(pfem_model_part.GetMesh()) - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(Time, pfem_model_part.GetMesh()) -# print "fluid output ****************************************************" - gid_io.WriteNodalResults(VELOCITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(PRESSURE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_FREE_SURFACE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_BOUNDARY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_STRUCTURE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(VISCOSITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DENSITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(BODY_FORCE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(FRICTION_COEFFICIENT, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_EROSIONABLE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(POROSITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DIAMETER, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(SEEPAGE_DRAG, pfem_model_part.Nodes, Time, 0) - - gid_io.Flush() - gid_io.FinalizeResults() - - next_output_time = Time + output_dt - - out = 0 - - out = out + 1 - step = step + 1 - print("step finished") - -print("solution finished") diff --git a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_fluid b/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_fluid deleted file mode 100644 index 9d5538c5dc22..000000000000 --- a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_fluid +++ /dev/null @@ -1,86 +0,0 @@ -PROBLEMTYPE pfem # The name of your problemtype -USE KRATOS DEFINITIONS # Use default definition for this problemtype... -USE PYTHON SCRIPTS pfem_scripts # ... but include my scripts from this folder - -VECTOR CONDITION DISPLACEMENT point line surface volume fixed 0.0 0.0 0.0 -VECTOR CONDITION VELOCITY point line surface volume fixed 0.0 0.0 0.0 -VECTOR CONDITION MESH_VELOCITY point line surface volume free 0.0 0.0 0.0 -VECTOR CONDITION BODY_FORCE point line surface volume free 0.0 0.0 0.0 -SCALAR CONDITION PRESSURE point line surface volume free 0.0 -SCALAR CONDITION EXTERNAL_PRESSURE point line surface volume free 0.0 -#SCALAR CONDITION VISCOSITY point line surface volume free 0.000001 -#SCALAR CONDITION DENSITY point line surface volume free 1.0 - -FLAG CONDITION IS_INTERFACE point line surface volume free 1.0 -FLAG CONDITION FLAG_VARIABLE point line surface volume free 1.0 2.0 3.0 4.0 5.0 -FLAG CONDITION IS_BOUNDARY point line surface volume free 1.0 2.0 3.0 4.0 5.0 -FLAG CONDITION IS_FREE_SURFACE point line surface volume free 1.0 0.0 -FLAG CONDITION IS_STRUCTURE point line surface volume free 1.0 0.0 - -FACE CONDITION Condition2D line -FACE CONDITION Condition3D surface -FACE CONDITION Fluid2DNeumann line -FACE CONDITION Fluid3DNeumann surface - -ELEMENT ASGS2D surface -ELEMENT Fluid2D surface -ELEMENT ASGS3D volume -ELEMENT Fluid3D volume -ELEMENT Fluid2DCoupled surface -ELEMENT Fluid3DCoupled volume - -#PROPERTY Density 1000.0 Density -#PROPERTY Viscosity 0.000001 Viscosity -PROPERTY Gravity_X 0.0 Gravity_X -PROPERTY Gravity_Y -9.806 Gravity_Y -PROPERTY Gravity_Z 0.0 Gravity_Z -PROPERTY density 1000.0 density -PROPERTY viscosity 0.000001 viscosity - -PROPERTY max_time 100.0 max_time -PROPERTY max_x 10.0 max_x -PROPERTY max_y 10.0 max_y -PROPERTY max_z 10.0 max_z -PROPERTY min_x -1.0 min_x -PROPERTY min_y -1.0 min_y -PROPERTY min_z -1.0 min_z -PROPERTY use_oss 0 use_oss -PROPERTY dynamic_tau 1 dynamic_tau -#PROPERTY nsteps 100 nsteps -PROPERTY output_dt 0.1 output_Dt -PROPERTY min_dt 0.001 min_dt -PROPERTY max_dt 0.1 max_dt -PROPERTY safety_factor 0.5 safety_factor - -#PROPERTY SolverType "pfem_solver_ale" "monolithic_solver_lagrangian" SolverType # remember to put the text between " " ! -TEXT FLAG PROPERTY SolverType monolithic_solver_lagrangian pfem_solver_ale SolverType # remember to put the text between " " ! -PROPERTY laplacian_form 3 laplacian_form - -DEFINE MODEL PART WallBoundary point line surface LOWER -ADD CONDITION VELOCITY point line surface volume fixed 0.0 0.0 0.0 -ADD CONDITION DISPLACEMENT point line surface volume fixed 0.0 0.0 0.0 -ADD CONDITION IS_STRUCTURE point line surface volume free 1.0 - -DEFINE MODEL PART FreeSurfaceBoundary point line surface LOWER -ADD CONDITION IS_FREE_SURFACE point line surface volume free 1.0 - -DEFINE BOUNDARY PART Boundary OUTWARDS NORMALS -ADD 2D ELEMENT Condition2D -ADD 3D ELEMENT Condition3D -ADD 2D CONDITION IS_BOUNDARY point line surface 1.0 - -# Part Interaction --> considering all of the combinations!!! -GROUP WallBoundary FreeSurfaceBoundary IN point line surface -WallBoundary FreeSurfaceBoundary ASSIGN VELOCITY fixed 0.0 0.0 0.0 DISPLACEMENT fixed 0.0 0.0 0.0 IS_STRUCTURE free 1.0 -# WallBoundary FreeSurfaceBoundary ASSIGN DISPLACEMENT fixed 0.0 0.0 0.0 -# WallBoundary FreeSurfaceBoundary ASSIGN IS_STRUCTURE free 1.0 - - - - - - - - - - diff --git a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_coupled b/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_coupled deleted file mode 100755 index abc841d72c62..000000000000 --- a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_coupled +++ /dev/null @@ -1,92 +0,0 @@ -PROBLEMTYPE pfem_nonewtonian_coupled # The name of your problemtype -USE KRATOS DEFINITIONS # Use default definition for this problemtype... -USE PYTHON SCRIPTS pfem_nonewtonian_coupled_scripts # ... but include my scripts from this folder - -VECTOR CONDITION DISPLACEMENT point line surface volume fixed 0.0 0.0 0.0 -VECTOR CONDITION VELOCITY point line surface volume fixed 0.0 0.0 0.0 -VECTOR CONDITION MESH_VELOCITY point line surface volume free 0.0 0.0 0.0 -#VECTOR CONDITION BODY_FORCE point line surface volume free 0.0 0.0 0.0 -SCALAR CONDITION PRESSURE point line surface volume free 0.0 -#SCALAR CONDITION INTERNAL_FRICTION_ANGLE point line surface volume free 1.0 -SCALAR CONDITION WATER_PRESSURE point line surface volume free 0.0 -SCALAR CONDITION EXTERNAL_PRESSURE point line surface volume free 0.0 -#SCALAR CONDITION VISCOSITY point line surface volume free 0.000001 -#SCALAR CONDITION DENSITY point line surface volume free 1.0 - -FLAG CONDITION IS_INTERFACE point line surface volume free 1.0 -FLAG CONDITION FLAG_VARIABLE point line surface volume free 1.0 2.0 3.0 4.0 5.0 -FLAG CONDITION IS_BOUNDARY point line surface volume free 1.0 2.0 3.0 4.0 5.0 -FLAG CONDITION IS_FREE_SURFACE point line surface volume free 1.0 0.0 -FLAG CONDITION IS_EROSIONABLE point line surface volume free 1.0 0.0 -FLAG CONDITION IS_STRUCTURE point line surface volume free 1.0 0.0 - -FACE CONDITION Condition2D line -FACE CONDITION Condition3D surface -FACE CONDITION Fluid2DNeumann line -FACE CONDITION Fluid3DNeumann surface - - -ELEMENT NoNewtonianASGS2D surface -ELEMENT NoNewtonianASGS3D volume - - -PROPERTY Solid_Density 1000.0 Density -PROPERTY Fluidified_Viscosity 0.001 Viscosity -PROPERTY Gravity_X 0.0 Gravity_X -PROPERTY Gravity_Y -9.806 Gravity_Y -PROPERTY Gravity_Z 0.0 Gravity_Z -PROPERTY Porosity 1.0 Porosity -PROPERTY Diameter 0.01 Diameter -PROPERTY Yield_Stress 1.0 Yield_Stress -PROPERTY m_coef 3000.0 m_coef -PROPERTY Friction_Angle_Tangent 1.0 Friction_Angle_Tangent - -#PROPERTY max_time 100.0 max_time -PROPERTY max_x 10.0 max_x -PROPERTY max_y 10.0 max_y -PROPERTY max_z 10.0 max_z -PROPERTY min_x -1.0 min_x -PROPERTY min_y -1.0 min_y -PROPERTY min_z -1.0 min_z -PROPERTY use_oss 0 use_oss -PROPERTY dynamic_tau 0.001 dynamic_tau -#PROPERTY nsteps 100 nsteps -#PROPERTY output_dt 0.1 output_Dt -PROPERTY min_dt 0.001 min_dt -PROPERTY max_dt 0.1 max_dt -#PROPERTY safety_factor 0.5 safety_factor - -#PROPERTY SolverType "monolithic_solver_lagrangian" "pfem_solver_ale" SolverType # remember to put the text between " " ! -#TEXT FLAG PROPERTY SolverType monolithic_solver_lagrangian pfem_solver_ale SolverType # remember to put the text between " " ! -PROPERTY laplacian_form 3 laplacian_form - -FILE SELECTION fluid_file fluid.mdpa fluid_file - -DEFINE MODEL PART WallBoundary point line surface LOWER -ADD CONDITION VELOCITY point line surface volume fixed 0.0 0.0 0.0 -ADD CONDITION DISPLACEMENT point line surface volume fixed 0.0 0.0 0.0 -ADD CONDITION IS_STRUCTURE point line surface volume free 1.0 - -DEFINE MODEL PART FreeSurfaceBoundary point line surface LOWER -ADD CONDITION IS_FREE_SURFACE point line surface volume free 1.0 - -DEFINE BOUNDARY PART Boundary OUTWARDS NORMALS -ADD 2D ELEMENT Condition2D -ADD 3D ELEMENT Condition3D -ADD 2D CONDITION IS_BOUNDARY point line surface 1.0 - -# Part Interaction --> considering all of the combinations!!! -GROUP WallBoundary FreeSurfaceBoundary IN point line surface -WallBoundary FreeSurfaceBoundary ASSIGN VELOCITY fixed 0.0 0.0 0.0 DISPLACEMENT fixed 0.0 0.0 0.0 IS_STRUCTURE free 1.0 -# WallBoundary FreeSurfaceBoundary ASSIGN DISPLACEMENT fixed 0.0 0.0 0.0 -# WallBoundary FreeSurfaceBoundary ASSIGN IS_STRUCTURE free 1.0 - - - - - - - - - - diff --git a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_coupled_scripts/script.py b/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_coupled_scripts/script.py deleted file mode 100644 index ce3eb1517d60..000000000000 --- a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_coupled_scripts/script.py +++ /dev/null @@ -1,440 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# import the configuration data as read from the GiD -import problem_settings -import time as timer -# -# -# setting the domain size for the problem to be solved -domain_size = problem_settings.domain_size - -# read from problem_settings name and path of fluid_gid_problem -# Acuario version********************************* -# fluid_path='.' - - -fluid_path = problem_settings.fluid_file.rpartition('/') -fluid_path = fluid_path[0] -import shutil -import os -shutil.copyfile(fluid_path + "/problem_settings.py", os.getcwd() + "/edgebased_levelset_var.py") - -# -# -# ATTENTION: here the order is important - -# including kratos path -import sys -sys.path.append(problem_settings.kratos_path) -sys.path.append(fluid_path) - -# importing Kratos main library -from KratosMultiphysics import * - -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * -from KratosMultiphysics.MKLSolversApplication import* - - -# from now on the order is not anymore crucial -# -# -import edgebased_levelset_var -import math - -# IMPORT BOTH FLUID AND STRUCTURAL SOLVERS -import edgebased_levelset_solver -import monolithic_solver_lagrangian_nonnewtonian - -# import cProfile - -# defining the TWO MODEL PARTS: pfem_model_part for the STRUCTURE and fixed_model_part for the FLUID -pfem_model_part = ModelPart("PfemFluidPart") -fixed_model_part = ModelPart("FixedFluidPart") - -# importing the fluid_solver files and adding the variablesv -edgebased_levelset_solver.AddVariables(fixed_model_part) -fixed_model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) -fixed_model_part.AddNodalSolutionStepVariable(POROSITY) -fixed_model_part.AddNodalSolutionStepVariable(DIAMETER) -fixed_model_part.AddNodalSolutionStepVariable(SEEPAGE_DRAG) -fixed_model_part.AddNodalSolutionStepVariable(STRUCTURE_VELOCITY) -# fixed_model_part.AddNodalSolutionStepVariable(VISCOSITY) - -# importing the structural_solver files and adding the variables -SolverType = "monolithic_solver_lagrangian" -monolithic_solver_lagrangian_nonnewtonian.AddVariables(pfem_model_part) -pfem_model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) -pfem_model_part.AddNodalSolutionStepVariable(IS_VISITED) -pfem_model_part.AddNodalSolutionStepVariable(IS_EROSIONABLE) -pfem_model_part.AddNodalSolutionStepVariable(FRICTION_COEFFICIENT) -pfem_model_part.AddNodalSolutionStepVariable(POROSITY) -pfem_model_part.AddNodalSolutionStepVariable(NODAL_MASS) -pfem_model_part.AddNodalSolutionStepVariable(DIAMETER) -pfem_model_part.AddNodalSolutionStepVariable(SEEPAGE_DRAG) -pfem_model_part.AddNodalSolutionStepVariable(WATER_PRESSURE) -# pfem_model_part.AddNodalSolutionStepVariable(AUX_INDEX) - - -# reading the models -name_pfem = problem_settings.problem_name -name_fixed = problem_settings.fluid_file - - -gid_mode = GiDPostMode.GiD_PostBinary -multifile = MultiFileFlag.MultipleFiles -deformed_mesh_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteElementsOnly - -gid_io = EdgebasedGidIO(name_pfem, gid_mode, multifile, deformed_mesh_flag, write_conditions) - -# READING FROM MULTIPLE .gid FILES######################## -# reading the pfem model part -model_part_io_structure = ModelPartIO(name_pfem) -model_part_io_structure.ReadModelPart(pfem_model_part) -print("pfem model read correctly") -# reading the fixed model part with the new porblem type format -model_part_io_fluid = ModelPartIO(name_fixed) -model_part_io_fluid.ReadModelPart(fixed_model_part) -print("fixed model read correctly") - -edgebased_levelset_solver.AddDofs(fixed_model_part) -monolithic_solver_lagrangian_nonnewtonian.AddDofs(pfem_model_part) - -# GET NODAL CONDITIONS FROM the PFEM model -body_force = Vector(3) -body_force[0] = problem_settings.Gravity_X -body_force[1] = problem_settings.Gravity_Y -body_force[2] = problem_settings.Gravity_Z -for node in pfem_model_part.Nodes: - node.SetSolutionStepValue(DENSITY, 0, problem_settings.Density) - node.SetSolutionStepValue(VISCOSITY, 0, problem_settings.Viscosity) - node.SetSolutionStepValue(POROSITY, 0, problem_settings.Porosity) - node.SetSolutionStepValue(DIAMETER, 0, problem_settings.Diameter) - node.SetSolutionStepValue(BODY_FORCE_X, 0, body_force[0]) - node.SetSolutionStepValue(BODY_FORCE_Y, 0, body_force[1]) - node.SetSolutionStepValue(BODY_FORCE_Z, 0, body_force[2]) - node.SetSolutionStepValue(YIELD_STRESS, 0, problem_settings.Yield_Stress) - node.SetSolutionStepValue(INTERNAL_FRICTION_ANGLE, 0, problem_settings.Friction_Angle_Tangent) -# node.SetSolutionStepValue(EFFECTIVE_VISCOSITY,0,problem_settings.Yield_Stress) -# node.SetSolutionStepValue(AUX_INDEX,0,0.0) - - -# GET NODAL CONDITIONS FROM the FIXED model -# we assume here that all of the internal nodes are marked with a negative distance -# set the distance of all of the internal nodes to a small value -small_value = 0.0001 -n_active = 0 -for node in fixed_model_part.Nodes: - dist = node.GetSolutionStepValue(DISTANCE) - if(dist < 0.0): - n_active = n_active + 1 - node.SetSolutionStepValue(DISTANCE, 0, -small_value) - else: - node.SetSolutionStepValue(DISTANCE, 0, small_value) -if(n_active == 0): - raise "ERROR. At least one node has to be initialized with a distance lesser than 0" - -# make sure that the porosity is not zero on any node (set by default to fluid only) -for node in fixed_model_part.Nodes: - if(node.GetSolutionStepValue(POROSITY) == 0.0): - node.SetSolutionStepValue(POROSITY, 0, 1.0) - if(node.GetSolutionStepValue(DIAMETER) == 0.0): - node.SetSolutionStepValue(DIAMETER, 0, 1.0) - -# print pfem_model_part -# print pfem_model_part.Properties - -# setting the limits of the bounding box -box_corner1 = Vector(3) -box_corner1[0] = problem_settings.min_x -box_corner1[1] = problem_settings.min_y -box_corner1[2] = problem_settings.min_z; -box_corner2 = Vector(3); -box_corner2[0] = problem_settings.max_x; -box_corner2[1] = problem_settings.max_y; -box_corner2[2] = problem_settings.max_z; - - -# the buffer size should be set up here after the mesh is read for the first time -pfem_model_part.SetBufferSize(2) -fixed_model_part.SetBufferSize(2) - - -# FLUID SOLVER CONSTRUCTION -fluid_viscosity = edgebased_levelset_var.viscosity -# print "***************** VISCOSITY *********************" -fluid_density = edgebased_levelset_var.density -solid_density = problem_settings.Density -# print "***************** DENSITY *********************" -fluid_solver = edgebased_levelset_solver.EdgeBasedLevelSetSolver(fixed_model_part, domain_size, body_force, fluid_viscosity, fluid_density) - -fluid_solver.redistance_frequency = edgebased_levelset_var.redistance_frequency -fluid_solver.extrapolation_layers = int(edgebased_levelset_var.extrapolation_layers) -fluid_solver.stabdt_pressure_factor = edgebased_levelset_var.stabdt_pressure_factor -fluid_solver.stabdt_convection_factor = edgebased_levelset_var.stabdt_convection_factor -fluid_solver.tau2_factor = edgebased_levelset_var.tau2_factor -fluid_solver.edge_detection_angle = edgebased_levelset_var.edge_detection_angle -fluid_solver.assume_constant_pressure = edgebased_levelset_var.assume_constant_pressure -fluid_solver.compute_porous_resistance_law = int(edgebased_levelset_var.compute_porous_resistance_law) # 0 = None; 1 = Ergun; 2 = Custom; - -# FLUID SOLVER INITIALIZATION -fluid_solver.Initialize() - -if(edgebased_levelset_var.wall_law_y > 1e-10): - fluid_solver.fluid_solver.ActivateWallResistance(edgebased_levelset_var.wall_law_y); - -# STRUCTURAL SOLVER CONSTRUCTION -# adding dofs to the structural solver -# defining the structural solver -structural_solver = monolithic_solver_lagrangian_nonnewtonian.MonolithicSolver(pfem_model_part, domain_size, box_corner1, box_corner2) -# setting solver parameters -structural_solver.oss_swith = int(problem_settings.use_oss) -structural_solver.dynamic_tau = problem_settings.dynamic_tau -structural_solver.regularization_coef = problem_settings.m_coef # m regularization coefficient in the exponential law of viscosity -structural_solver.echo_level = 2 -# problem parameters to be changed -# time setting pfem -# pfem implicit -max_dt = problem_settings.max_dt -min_dt = problem_settings.min_dt -# edgebased explicit -max_Dt = edgebased_levelset_var.max_time_step -initial_Dt_ls = 0.001 * max_Dt - -final_time = edgebased_levelset_var.max_time -output_dt = edgebased_levelset_var.output_dt -safety_factor = edgebased_levelset_var.safety_factor - -number_of_inital_steps = edgebased_levelset_var.number_of_inital_steps -initial_time_step = edgebased_levelset_var.initial_time_step - -structural_solver.max_iter = 10 -print("max iterations non-newtonian solver = 10") - -# STRUCTURAL SOLVER INITIALIZATION -structural_solver.Initialize(output_dt) - - -# PROJECTION MODULE INITIALIZATION -if (domain_size == 3): - ProjectionModule = BinBasedSeepageCoupledMapping3D() - bin_of_objects_fixed = BinBasedFastPointLocator3D(fixed_model_part) - bin_of_nodes_fixed = BinBasedNodesInElementLocator3D(fixed_model_part) -else: - ProjectionModule = BinBasedSeepageCoupledMapping2D() - bin_of_objects_fixed = BinBasedFastPointLocator2D(fixed_model_part) - bin_of_nodes_fixed = BinBasedNodesInElementLocator2D(fixed_model_part) - -hmin = 0.01 -# Fill the bins -bin_of_objects_fixed.UpdateSearchDatabaseAssignedSize(hmin) -bin_of_nodes_fixed.UpdateSearchDatabaseAssignedSize(hmin) - -PfemUtils = PfemUtils(); -DragUtils = DragUtils(); - -#------------------------------------------------------------------------ -ProjectionModule.InterpolationFromMovingMesh(pfem_model_part, fixed_model_part, bin_of_nodes_fixed) - - -out = 0 - -original_max_dt = max_Dt -time = 0.0 -step = 0 -next_output_time = output_dt -max_safety_factor = safety_factor - - -check_structure_dt = True -print_structure = True -next_structure_step = time - -t0 = timer.time() -while(time < final_time): -# print "line49" - - if(step < number_of_inital_steps): - max_Dt = initial_time_step - else: - max_Dt = original_max_dt - # progressively increment the safety factor - # in the steps that follow a reduction of it - safety_factor = safety_factor * 1.2 - if(safety_factor > max_safety_factor): - safety_factor = max_safety_factor - - # CALCULATE FLUID_DT AND STRUCTURE_DT - # check which of the dime step is more restrictive - fluid_dt = fluid_solver.EstimateTimeStep(safety_factor, max_Dt) - if(check_structure_dt): - if(step < 2.0 * number_of_inital_steps): - structure_dt = min_dt - else: - structure_dt = structural_solver.EstimateDeltaTime(min_dt, max_dt) - - # check which of the dime step is more restrictive - if(structure_dt <= fluid_dt): - Dt = structure_dt - next_structure_step = time - else: - Dt = fluid_dt - if(structure_dt * safety_factor > 10.0 * fluid_dt): - next_structure_step = time + 10.0 * fluid_dt - else: - next_structure_step = time + safety_factor * structure_dt - check_structure_dt = False - else: - Dt = fluid_dt - - print("fluid_dt = ", fluid_dt) - print("structure_dt = ", structure_dt) - print("Dt = ", Dt) - - print("next_structure_step =", next_structure_step) - - time = time + Dt - fixed_model_part.CloneTimeStep(time) - - print("******** CURRENT TIME = ", time) - - if(step > 3): - #------------------------------------------------------------------------ - ProjectionModule.InterpolationFromMovingMesh(pfem_model_part, fixed_model_part, bin_of_nodes_fixed) - # solving the fluid problem ........................................................................................... - print("starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~") - fluid_solver.Solve(); - print("finished solving fluid edgebased") - - print("start checking the time stepping") - check_dt = fluid_solver.EstimateTimeStep(0.95, max_Dt) - - if(check_dt < Dt): - print("***********************************************************") - print("***********************************************************") - print("***********************************************************") - print(" *** REDUCING THE TIME STEP ***") - print("***********************************************************") - print("***********************************************************") - print("***********************************************************") - - # we found a velocity too large! we need to reduce the time step - fluid_solver.fluid_solver.ReduceTimeStep(fixed_model_part, time) # this is to set the database to the value at the beginning of the step - - safety_factor *= edgebased_levelset_var.reduction_on_failure - reduced_dt = fluid_solver.EstimateTimeStep(safety_factor, max_Dt) - - print("time before reduction= ", time) - time = time - Dt + reduced_dt - print("reduced time = ", time) - print("Dt = ", Dt) - print("reduced_dt = ", reduced_dt) - - fluid_solver.fluid_solver.ReduceTimeStep(fixed_model_part, time) # this is to set the database to the value at the beginning of the step - fluid_solver.Solve() - print("finished checking the time stepping") - print(fixed_model_part) - - if(time >= next_structure_step): - - pfem_model_part.CloneTimeStep(time) - if(time > 0.0): - print(pfem_model_part) - # solving the structural problem ........................................................................................... - print("starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~") - PfemUtils.CalculateNodalMass(pfem_model_part, domain_size) - - #------------------------------------------------------------------------ - # Calculating Darcy non linear term - DragUtils.CalculateFluidDrag(fixed_model_part, SEEPAGE_DRAG, fluid_viscosity, fluid_density, solid_density) - ProjectionModule.InterpolationFromFixedMesh(fixed_model_part, pfem_model_part, bin_of_objects_fixed) - # Adding Darcy non linear term and Water weight to the external force - DragUtils.AddDrag(pfem_model_part, SEEPAGE_DRAG, BODY_FORCE, body_force) - - # PFEM steps - structural_solver.Remesh(); - (structural_solver.solver).Solve(); - structural_solver.RestoreOldPosition() - - (structural_solver.PfemUtils).MoveLonelyNodes(pfem_model_part) - (structural_solver.solver).Clear(); - - check_structure_dt = True - print_structure = True - print("finished solving structure") - -# - if(time >= next_output_time): - - # a change in the output name is needed!!!! - res_name1 = str(name_fixed) - gid_io.ChangeOutputName(res_name1) - gid_io.InitializeMesh(time); - gid_io.WriteMesh(fixed_model_part.GetMesh()) - gid_io.FinalizeMesh(); - gid_io.InitializeResults(time, fixed_model_part.GetMesh()) -# print "structure output ****************************************************" - gid_io.WriteNodalResults(VELOCITY, fixed_model_part.Nodes, time, 0) -# gid_io.WriteNodalResults(CONV_VELOCITY,fixed_model_part.Nodes,time,0) - gid_io.WriteNodalResults(PRESSURE, fixed_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(DISTANCE, fixed_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(PRESS_PROJ, fixed_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(POROSITY, fixed_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(DIAMETER, fixed_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(SEEPAGE_DRAG, fixed_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(STRUCTURE_VELOCITY, fixed_model_part.Nodes, time, 0) - - gid_io.Flush() - gid_io.FinalizeResults() - -# if(time > 0.0): ## only for ??? !!!! - if(print_structure): # only for ??? !!!! - - res_name2 = str(name_pfem) - gid_io.ChangeOutputName(res_name2) - gid_io.InitializeMesh(time); - gid_io.WriteNodeMesh(pfem_model_part.GetMesh()); - gid_io.WriteMesh(pfem_model_part.GetMesh()) - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(time, pfem_model_part.GetMesh()) - # print "fluid output ****************************************************" - gid_io.WriteNodalResults(VELOCITY, pfem_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(PRESSURE, pfem_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(IS_FREE_SURFACE, pfem_model_part.Nodes, time, 0) - # gid_io.WriteNodalResults(IS_BOUNDARY,pfem_model_part.Nodes,time,0) - gid_io.WriteNodalResults(IS_STRUCTURE, pfem_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(VISCOSITY, pfem_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(DENSITY, pfem_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(BODY_FORCE, pfem_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(DISPLACEMENT, pfem_model_part.Nodes, time, 0) - # gid_io.WriteNodalResults(FRICTION_COEFFICIENT,pfem_model_part.Nodes,time,0) - # gid_io.WriteNodalResults(IS_EROSIONABLE,pfem_model_part.Nodes,time,0) - gid_io.WriteNodalResults(POROSITY, pfem_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(DIAMETER, pfem_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(SEEPAGE_DRAG, pfem_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(WATER_PRESSURE, pfem_model_part.Nodes, time, 0) - gid_io.PrintOnGaussPoints(EQ_STRAIN_RATE, pfem_model_part, time) - gid_io.PrintOnGaussPoints(MU, pfem_model_part, time) - gid_io.PrintOnGaussPoints(TAU, pfem_model_part, time) - gid_io.WriteNodalResults(NODAL_H, pfem_model_part.Nodes, time, 0); - gid_io.WriteNodalResults(EXTERNAL_PRESSURE, pfem_model_part.Nodes, time, 0); - gid_io.WriteNodalResults(PRESS_PROJ, pfem_model_part.Nodes, time, 0); - - gid_io.Flush() - gid_io.FinalizeResults() - - print_structure = False - - next_output_time = time + output_dt - - out = 0 - - out = out + 1 - step = step + 1 - print("step finished") - -print("solution finished") -t1 = timer.time() -print("Solution time with the new projection module ", t1 - t0) diff --git a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_fluid b/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_fluid deleted file mode 100755 index 6cf7bc6ee396..000000000000 --- a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_fluid +++ /dev/null @@ -1,88 +0,0 @@ -PROBLEMTYPE pfem_nonewtonian # The name of your problemtype -USE KRATOS DEFINITIONS # Use default definition for this problemtype... -USE PYTHON SCRIPTS pfem_nonewtonian_scripts # ... but include my scripts from this folder - -VECTOR CONDITION DISPLACEMENT point line surface volume fixed 0.0 0.0 0.0 -VECTOR CONDITION VELOCITY point line surface volume fixed 0.0 0.0 0.0 -VECTOR CONDITION MESH_VELOCITY point line surface volume free 0.0 0.0 0.0 -SCALAR CONDITION PRESSURE point line surface volume free 0.0 -#SCALAR CONDITION INTERNAL_FRICTION_ANGLE point line surface volume free 1.0 -SCALAR CONDITION EXTERNAL_PRESSURE point line surface volume free 0.0 - -FLAG CONDITION IS_INTERFACE point line surface volume free 1.0 -FLAG CONDITION FLAG_VARIABLE point line surface volume free 1.0 2.0 3.0 4.0 5.0 -FLAG CONDITION IS_BOUNDARY point line surface volume free 1.0 2.0 3.0 4.0 5.0 -FLAG CONDITION IS_FREE_SURFACE point line surface volume free 1.0 0.0 -FLAG CONDITION IS_STRUCTURE point line surface volume free 1.0 0.0 - -FACE CONDITION Condition2D line -FACE CONDITION Condition3D surface -FACE CONDITION Fluid2DNeumann line -FACE CONDITION Fluid3DNeumann surface - -ELEMENT NoNewtonianASGS2D surface -ELEMENT BinghamNonNewtonianASGS2D surface -ELEMENT NoNewtonianASGS3D volume -ELEMENT BinghamNonNewtonianASGS3D volume - -#OPTION 2D_Body_Element surface NoNewtonianASGS2D -#OPTION 3D_Body_Element volume NoNewtonianASGS3D - -PROPERTY Density 1000.0 Density -PROPERTY Viscosity 0.000001 Viscosity -PROPERTY Gravity_X 0.0 Gravity_X -PROPERTY Gravity_Y -9.806 Gravity_Y -PROPERTY Gravity_Z 0.0 Gravity_Z -PROPERTY Friction_Angle_Tangent 1.0 Friction_Angle_Tangent -PROPERTY Yield_Stress 1.0 Yield_Stress -PROPERTY m_coef 3000.0 m_coef - -PROPERTY max_time 10.0 max_time -PROPERTY max_x 10.0 max_x -PROPERTY max_y 10.0 max_y -PROPERTY max_z 10.0 max_z -PROPERTY min_x -1.0 min_x -PROPERTY min_y -1.0 min_y -PROPERTY min_z -1.0 min_z -PROPERTY use_oss 0 use_oss -PROPERTY dynamic_tau 1.0 dynamic_tau -#PROPERTY nsteps 100 nsteps -PROPERTY output_dt 0.1 output_Dt -PROPERTY min_dt 0.001 min_dt -PROPERTY max_dt 0.1 max_dt -PROPERTY safety_factor 0.5 safety_factor - -#PROPERTY SolverType "pfem_solver_ale" "monolithic_solver_lagrangian" SolverType # remember to put the text between " " ! -#TEXT FLAG PROPERTY SolverType pfem_solver_ale monolithic_solver_lagrangian SolverType # remember to put the text between " " ! -PROPERTY laplacian_form 3 laplacian_form - -DEFINE MODEL PART WallBoundary point line surface LOWER -ADD CONDITION VELOCITY point line surface volume fixed 0.0 0.0 0.0 -ADD CONDITION DISPLACEMENT point line surface volume fixed 0.0 0.0 0.0 -ADD CONDITION IS_STRUCTURE point line surface volume free 1.0 - -DEFINE MODEL PART FreeSurfaceBoundary point line surface LOWER -ADD CONDITION IS_FREE_SURFACE point line surface volume free 1.0 - -DEFINE BOUNDARY PART Boundary OUTWARDS NORMALS -ADD 2D ELEMENT Condition2D -ADD 3D ELEMENT Condition3D -ADD 2D CONDITION IS_BOUNDARY point line surface 1.0 - -# Part Interaction --> considering all of the combinations!!! -GROUP WallBoundary FreeSurfaceBoundary IN point line surface -WallBoundary FreeSurfaceBoundary ASSIGN VELOCITY FROM WallBoundary -WallBoundary FreeSurfaceBoundary ASSIGN DISPLACEMENT FROM WallBoundary -WallBoundary FreeSurfaceBoundary ASSIGN IS_STRUCTURE FROM WallBoundary - - - - - - - - - - - - diff --git a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_scripts/script.py b/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_scripts/script.py deleted file mode 100755 index 20f91daf1c44..000000000000 --- a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_nonewtonian_scripts/script.py +++ /dev/null @@ -1,127 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# import the configuration data as read from the GiD -import problem_settings - -# -# -# setting the domain size for the problem to be solved -domain_size = problem_settings.domain_size - -# -# -# ATTENTION: here the order is important - -# including kratos path -import sys -sys.path.append(problem_settings.kratos_path) - -# importing Kratos main library -from KratosMultiphysics import * - -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * -from KratosMultiphysics.MKLSolversApplication import* - -# from now on the order is not anymore crucial -# -# - -# defining a model part -model_part = ModelPart("FluidPart") - -# importing the solver files and adding the variables -import monolithic_solver_lagrangian_nonnewtonian -monolithic_solver_lagrangian_nonnewtonian.AddVariables(model_part) - -# reading a model -name = problem_settings.problem_name - -gid_mode = GiDPostMode.GiD_PostBinary -multifile = MultiFileFlag.MultipleFiles -deformed_mesh_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteElementsOnly -gid_io = GidIO(name, gid_mode, multifile, deformed_mesh_flag, write_conditions) -model_part_io = ModelPartIO(name) -model_part_io.ReadModelPart(model_part) - -# assigning density viscosity and gravity acceleration -for node in model_part.Nodes: - node.SetSolutionStepValue(DENSITY, 0, problem_settings.Density) - node.SetSolutionStepValue(VISCOSITY, 0, problem_settings.Viscosity) - node.SetSolutionStepValue(BODY_FORCE_X, 0, problem_settings.Gravity_X) - node.SetSolutionStepValue(BODY_FORCE_Y, 0, problem_settings.Gravity_Y) - node.SetSolutionStepValue(BODY_FORCE_Z, 0, problem_settings.Gravity_Z) - node.SetSolutionStepValue(INTERNAL_FRICTION_ANGLE, 0, problem_settings.Friction_Angle_Tangent) - node.SetSolutionStepValue(YIELD_STRESS, 0, problem_settings.Yield_Stress) - -# initializing the mesh -mesh_name = 0.0 -gid_io.InitializeMesh(mesh_name) -gid_io.WriteMesh((model_part).GetMesh()) -gid_io.FinalizeMesh() - -print(model_part) -print(model_part.Properties) - -# setting the limits of the bounding box -box_corner1 = Vector(3) -box_corner1[0] = problem_settings.min_x -box_corner1[1] = problem_settings.min_y -box_corner1[2] = problem_settings.min_z -box_corner2 = Vector(3) -box_corner2[0] = problem_settings.max_x; -box_corner2[1] = problem_settings.max_y; -box_corner2[2] = problem_settings.max_z; - -# time setting -output_Dt = problem_settings.output_Dt -max_dt = problem_settings.max_dt -min_dt = problem_settings.min_dt -safety_factor = problem_settings.safety_factor -final_time = problem_settings.max_time - -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(2) - - -# adding dofs -monolithic_solver_lagrangian_nonnewtonian.AddDofs(model_part) -# defining the solver -solver = monolithic_solver_lagrangian_nonnewtonian.MonolithicSolver(model_part, domain_size, box_corner1, box_corner2) -# setting solver parameters -solver.oss_switch = int(problem_settings.use_oss) # OSS = 1; ASGS = 0; -solver.dynamic_tau = problem_settings.dynamic_tau -solver.regularization_coef = problem_settings.m_coef # m regularization coefficient in the exponential law of viscosity -solver.echo_level = 2 - -solver.max_iter = 8 -print("max iterations non-newtonian solver = 8") -# Initializing the solver -solver.Initialize(output_Dt) - -step = 0 -time = 0.0 -# for step in range(0,nsteps): -while(time < final_time): -# print "line49" - - if(step < 10): - time = time + min_dt - else: - new_Dt = solver.EstimateDeltaTime(min_dt, max_dt) - time = time + new_Dt * safety_factor -# print 'Delta Time = ', new_Dt -# print 'Safety factor = ', safety_factor - -# print 'Time = ', time - - model_part.CloneTimeStep(time) - - print(time) - - # solving the fluid problem - if(step > 3): - solver.Solve(time, gid_io) - - step = step + 1 diff --git a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_scripts/script.py b/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_scripts/script.py deleted file mode 100644 index 96ce569444c9..000000000000 --- a/applications/PFEMapplication/custom_problemtype/problemtype_generator/pfem_scripts/script.py +++ /dev/null @@ -1,138 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# import the configuration data as read from the GiD -import problem_settings - -# -# -# setting the domain size for the problem to be solved -domain_size = problem_settings.domain_size - -# -# -# ATTENTION: here the order is important - -# including kratos path -import sys -sys.path.append(problem_settings.kratos_path) - -# importing Kratos main library -from KratosMultiphysics import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * -from KratosMultiphysics.ExternalSolversApplication import * - -# from now on the order is not anymore crucial -# -# - -# defining a model part -model_part = ModelPart("FluidPart") - -# importing the solver files and adding the variables -SolverType = problem_settings.SolverType - -if(SolverType == "pfem_solver_ale"): - import pfem_solver_ale - pfem_solver_ale.AddVariables(model_part) -elif(SolverType == "monolithic_solver_lagrangian"): - import monolithic_solver_lagrangian - monolithic_solver_lagrangian.AddVariables(model_part) -else: - raise "solver type not supported: options are FractionalStep - Monolithic" - - -# reading a model -name = problem_settings.problem_name - -gid_mode = GiDPostMode.GiD_PostBinary -multifile = MultiFileFlag.MultipleFiles -deformed_mesh_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteElementsOnly -gid_io = GidIO(name, gid_mode, multifile, deformed_mesh_flag, write_conditions) -model_part_io = ModelPartIO(name) -model_part_io.ReadModelPart(model_part) - -# check to ensure that no node has zero density or pressure -for node in model_part.Nodes: - node.SetSolutionStepValue(BODY_FORCE_X, 0, problem_settings.Gravity_X) - node.SetSolutionStepValue(BODY_FORCE_Y, 0, problem_settings.Gravity_Y) - node.SetSolutionStepValue(BODY_FORCE_Z, 0, problem_settings.Gravity_Z) - node.SetSolutionStepValue(DENSITY, 0, problem_settings.density) - node.SetSolutionStepValue(VISCOSITY, 0, problem_settings.viscosity) - - -mesh_name = 0.0 -gid_io.InitializeMesh(mesh_name) -gid_io.WriteMesh((model_part).GetMesh()) -gid_io.FinalizeMesh() - -print(model_part) -print(model_part.Properties) - -# setting the limits of the bounding box -box_corner1 = Vector(3) -box_corner1[0] = problem_settings.min_x -box_corner1[1] = problem_settings.min_y -box_corner1[2] = problem_settings.min_z -box_corner2 = Vector(3) -box_corner2[0] = problem_settings.max_x; -box_corner2[1] = problem_settings.max_y; -box_corner2[2] = problem_settings.max_z; - -# time setting -output_Dt = problem_settings.output_Dt -max_dt = problem_settings.max_dt -min_dt = problem_settings.min_dt -safety_factor = problem_settings.safety_factor -# nsteps = int(problem_settings.nsteps) -final_time = problem_settings.max_time -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(2) - -if(SolverType == "pfem_solver_ale"): - # adding dofs - pfem_solver_ale.AddDofs(model_part) - # creating a fluid solver object - solver = pfem_solver_ale.PFEMSolver(model_part, name, box_corner1, box_corner2, domain_size) - solver.laplacian_form = int(problem_settings.laplacian_form) - solver.echo_level = 0 - solver.prediction_order = 1 - solver.predictor_corrector = True - solver.smooth = True - solver.alpha_shape = 1.2 - solver.max_press_its = 3; - # initializing the solver - initial_dt = 0.001 * min_dt - solver.Initialize(initial_dt, output_Dt) -elif(SolverType == "monolithic_solver_lagrangian"): - # adding dofs - monolithic_solver_lagrangian.AddDofs(model_part) - solver = monolithic_solver_lagrangian.MonolithicSolver(model_part, domain_size, box_corner1, box_corner2) - solver.oss_swith = int(problem_settings.use_oss) - solver.dynamic_tau = int(problem_settings.dynamic_tau) - solver.echo_level = 2 - - solver.Initialize(output_Dt) - - -# -time = 0.0 -step = 0 -# for step in range(0,nsteps): -while(time < final_time): - print("line49") - - new_Dt = solver.EstimateDeltaTime(min_dt, max_dt) - - time = time + new_Dt * safety_factor - - model_part.CloneTimeStep(time) - - print(time) - - # solving the fluid problem - if(step > 3): - solver.Solve(time, gid_io) - - step = step + 1 diff --git a/applications/PFEMapplication/custom_processes/act_on_walls_nodal_process.h b/applications/PFEMapplication/custom_processes/act_on_walls_nodal_process.h deleted file mode 100644 index 18c8bda465c8..000000000000 --- a/applications/PFEMapplication/custom_processes/act_on_walls_nodal_process.h +++ /dev/null @@ -1,387 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_ACT_ON_WALLS_NODAL_PROCESS_H_INCLUDED ) -#define KRATOS_ACT_ON_WALLS_NODAL_PROCESS_H_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "includes/deprecated_variables.h" - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. -//assign a size to each node depending on the distance fof the neighbouring nodes -*/ - -class ActOnWallsNodalProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of ActOnWallsNodalProcess - KRATOS_CLASS_POINTER_DEFINITION(ActOnWallsNodalProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - ActOnWallsNodalProcess(ModelPart& model_part) - : mr_model_part(model_part) - { - } - - /// Destructor. - virtual ~ActOnWallsNodalProcess() - { - } - - /// Copy constructor. - //ActOnWallsNodalProcess(ActOnWallsNodalProcess const& rOther); - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - //removes the velocity towards the wall for all the nodes which are getting to close - virtual void Execute() - { - KRATOS_TRY - - array_1d n, final_pos; - array_1d dist, corrective_disp, delta_disp_wall; - - for(ModelPart::NodesContainerType::iterator i = mr_model_part.NodesBegin(); - i!=mr_model_part.NodesEnd(); i++) - { - // const WeakPointerVector >& rN = i->GetValue(NEIGHBOUR_NODES); - - //if the conditions is composed only by wall nodes remove a percentage of the velocity - if( i->FastGetSolutionStepValue(IS_STRUCTURE) == 1 - && (i->GetValue(NEIGHBOUR_NODES)).size() != 0) - { - - noalias(n) = i->FastGetSolutionStepValue(NORMAL_TO_WALL); - double A = inner_prod(n,n); - A = sqrt(A); - const array_1d& disp_wall = i->FastGetSolutionStepValue(DISPLACEMENT); - const array_1d& disp_wall_old = i->FastGetSolutionStepValue(DISPLACEMENT,1); - noalias(delta_disp_wall) = disp_wall; - noalias(delta_disp_wall) -= disp_wall_old; - if(A != 0) - { - n /= A; - - double x = i->X(); - double y = i->Y(); - double z = i->Z(); - double h = i->FastGetSolutionStepValue(NODAL_H); - - WeakPointerVector >& rN = i->GetValue(NEIGHBOUR_NODES); - for(WeakPointerVector >::iterator in = rN.begin(); in != rN.end(); in++) - { - if(in->FastGetSolutionStepValue(IS_STRUCTURE) == 0) //for nodes that are not of structure - { - //calculating the distance along the normal and orhtogonal to the normal - array_1d& disp = in->FastGetSolutionStepValue(DISPLACEMENT); - array_1d& olddisp = in->FastGetSolutionStepValue(DISPLACEMENT,1); - - array_1d delta_disp = disp; - noalias(delta_disp) -= olddisp; - - //calculating the end of the step position - final_pos[0] = in->X0(); - final_pos[1] = in->Y0(); - final_pos[2] = in->Z0(); - noalias(final_pos) += disp; - - //calculating the distance at the end of the step - noalias(dist) = final_pos; - dist[0] = final_pos[0] - x; - dist[1] = final_pos[1] - y; - dist[2] = final_pos[2] - z; - - double dist_2 = inner_prod(dist,dist); - double dist_n = inner_prod(dist,n); - double dist_n2 = dist_n * dist_n; - double dist_ort2 = dist_2 - dist_n2; - - //verify that the final position of the point is close to the normal in the wall node - if(dist_ort2 < 0.5*h*h) - { - //verify if the final position of the normal closer than 0.75h to the face (distance along the normal) - if(dist_n > -0.5 * h) - { - double a = inner_prod(delta_disp,n); - - //if it is moving towards the outside put it back - // to the allowed distance of 0.75h on the interior - if(a > 0) - { - double coeff = - 0.5*h - dist_n; - noalias(disp) += coeff * n; - noalias(disp) += delta_disp_wall; - } - - } - - } - - } - } - } - } - } - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "ActOnWallsNodalProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "ActOnWallsNodalProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - - ///@} - ///@name Private Operators - ///@{ - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - //7/@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - ActOnWallsNodalProcess& operator=(ActOnWallsNodalProcess const& rOther); - - - - ///@} - -}; // Class ActOnWallsNodalProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - ActOnWallsNodalProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const ActOnWallsNodalProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_ACT_ON_WALLS_NODAL_PROCESS_H_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/assign_pressure_force_process.h b/applications/PFEMapplication/custom_processes/assign_pressure_force_process.h deleted file mode 100755 index 0ee240819268..000000000000 --- a/applications/PFEMapplication/custom_processes/assign_pressure_force_process.h +++ /dev/null @@ -1,320 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-01-23 15:38:00 $ -// Revision: $Revision: 1.1 $ -// -// -// This process creates a pressue_force condition at each node - -#if !defined(KRATOS_ASSIGN_PRESSURE_FORCE_PROCESS_INCLUDED ) -#define KRATOS_ASSIGN_PRESSURE_FORCE_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "custom_elements/updated_lagrangian_fluid.h" -#include "custom_conditions/pressure_cond.h" -#include "custom_conditions/pressure_cond3d.h" - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. - calculate the nodal H for all the nodes depending on the min distance - of the neighbouring nodes. - - lonely nodes are given the average value of the H -*/ - -class AssignPressureForceProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of PressureContributionProcess - KRATOS_CLASS_POINTER_DEFINITION(AssignPressureForceProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - AssignPressureForceProcess(ModelPart& model_part) - : mr_model_part(model_part) - { - } - - /// Destructor. - virtual ~AssignPressureForceProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - virtual void Execute() - { - KRATOS_TRY - //first erase all the conditions - mr_model_part.Conditions().clear(); - unsigned int dim = mr_model_part.ElementsBegin()->GetGeometry().WorkingSpaceDimension(); - - ModelPart::ConditionsContainerType& rConds = mr_model_part.Conditions(); - - int end_id = 0; - if (rConds.size()!=0) - end_id = (rConds.end()-1)->Id(); - - - for(ModelPart::NodesContainerType::iterator in = mr_model_part.NodesBegin() ; - in != mr_model_part.NodesEnd() ; ++in) - { - if(in->GetValue(NEIGHBOUR_ELEMENTS).size() != 0) - { - Condition::NodesArrayType temp; - temp.reserve(1); - // temp.push_back(*in); - temp.push_back(*(in.base())); - - Geometry< Node<3> >::Pointer cond = - Geometry< Node<3> >::Pointer(new Geometry< Node<3> >(temp) ); - - //if(cond.size() != 1) - // KRATOS_WATCH("aaaaaaaaahhhhhhhhhhhhhhhhhhhhhhhhhhhhhhhh") - - int id = end_id+1; - //in->Id(); - // - //CHECK OUT IF THAT IS CORRECT!!!! (just the next line) - //PressureCond::Pointer p_cond = PressureCond::Pointer(new PressureCond(id, cond) ); - if (dim==2) - { - Condition::Pointer p_cond = Condition::Pointer(new PressureCond(id, cond) ); - //Condition::Pointer(new Condition(id, cond) ); - //p_cond. - end_id++; - mr_model_part.Conditions().push_back(p_cond); - } - if (dim==3) - { - Condition::Pointer p_cond = Condition::Pointer(new PressureCond3D(id, cond) ); - //Condition::Pointer(new Condition(id, cond) ); - //p_cond. - end_id++; - mr_model_part.Conditions().push_back(p_cond); - } - - - - } - } - - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "AssignPressureForceProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "AssignPressureForceProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - double m_min_h; - - - ///@} - ///@name Private Operators - ///@{ - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. -// AssignPressureForceProcess& operator=(AssignPressureForceProcess const& rOther); - - /// Copy constructor. -// AssignPressureForceProcess(AssignPressureForceProcess const& rOther); - - - ///@} - -}; // Class AssignPressureForceProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - AssignPressureForceProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const AssignPressureForceProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_ASSIGN_PRESSURE_FORCE_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/coordinate_laplacian_smoother_process.h b/applications/PFEMapplication/custom_processes/coordinate_laplacian_smoother_process.h deleted file mode 100644 index e4f24bf049b6..000000000000 --- a/applications/PFEMapplication/custom_processes/coordinate_laplacian_smoother_process.h +++ /dev/null @@ -1,404 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.3 $ -// -// - - -#if !defined(KRATOS_COORDINATE_LAPLACIAN_SMOOTHER_PROCESS_INCLUDED ) -#define KRATOS_COORDINATE_LAPLACIAN_SMOOTHER_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "includes/deprecated_variables.h" - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. -This process calculates and moves the mesh in a Lagrangian way -using the formula -d(n+1) = d(n) + v(n)*dt + 0.5*a(n)*dt*dt -to do so it requires to recovery the material acceleration a(n) from the knowledge -of the eulerian solution at the steps n and n+1 -a(n) = (v(n+1) - v(n))/Dt + dv/dx*(v-vm) -*/ - -class CoordinateLaplacianSmootherProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of CoordinateLaplacianSmootherProcess - KRATOS_CLASS_POINTER_DEFINITION(CoordinateLaplacianSmootherProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - CoordinateLaplacianSmootherProcess(ModelPart& model_part, int number_of_loops = 20, double reduction_factor = 1.0) - : mr_model_part(model_part),mreduction_factor(reduction_factor) - { - KRATOS_TRY - mNumberOfLoops = number_of_loops; - KRATOS_CATCH("") - } - - /// Destructor. - virtual ~CoordinateLaplacianSmootherProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - virtual void Execute() - { - KRATOS_TRY; - - double relaxation_param = 1.00/double(mNumberOfLoops); - - relaxation_param *= mreduction_factor; - - double Dt = mr_model_part.GetProcessInfo()[DELTA_TIME]; - - for(unsigned int iloops=0; iloopsFastGetSolutionStepValue(IS_BOUNDARY) == 0) - { - array_1d& disp = i->FastGetSolutionStepValue(DISPLACEMENT); - - disp[0] = i->X() - i->X0(); - disp[1] = i->Y() - i->Y0(); - disp[2] = i->Z() - i->Z0(); - } - } - - - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "CoordinateLaplacianSmootherProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "CoordinateLaplacianSmootherProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - unsigned int mNumberOfLoops; - double mreduction_factor; - - - ///@} - ///@name Private Operators - ///@{ - void SmoothingLoopOnNodes(double relaxation_param, double Dt) - { - KRATOS_TRY - - array_1d new_disp; - array_1d zero = ZeroVector(3); - array_1d aux; - double complement_param = 1.00 - relaxation_param; - //performs a laplacian smoothing over the incremental displacements - for(ModelPart::NodeIterator i = mr_model_part.NodesBegin() ; - i != mr_model_part.NodesEnd() ; ++i) - { - WeakPointerVector< Node<3> >& neighbours = (i->GetValue(NEIGHBOUR_NODES)); - - double nneigh = neighbours.size(); - if( nneigh != 0.00 && //if it has neighoburs - i->GetSolutionStepValue(IS_BOUNDARY) == 0 && - i->GetSolutionStepValue(IS_STRUCTURE) == 0 ) //and it is not on the boundary - { - double xnew = 0.0; - double ynew = 0.0; - double znew = 0.0; - double xold = i->X(); - double yold = i->Y(); - double zold = i->Z(); - - for(WeakPointerVector< Node<3> >::iterator ii = neighbours.begin() ; - ii != neighbours.end() ; ++ii) - { - xnew += ii->X(); - ynew += ii->Y(); - znew += ii->Z(); - } - xnew/=nneigh; - ynew/=nneigh; - znew/=nneigh; - - i->X() = complement_param * xold + relaxation_param*xnew ; - i->Y() = complement_param * yold + relaxation_param*ynew ; - i->Z() = complement_param * zold + relaxation_param*znew ; - -// //verify that the displacement does not exceed the maximum allowable -// const array_1d& vel = i->GetSolutionStepValue(VELOCITY); -// double v = inner_prod(vel,vel); v = sqrt(v); -// -// double max_disp = v * Dt ; -// // std::cout << v << " " << Dt << " " << relaxation_param << " " << max_disp << std::endl; -// aux[0] = i->X() - xold; -// aux[1] = i->Y() - yold; -// aux[2] = i->Z() - zold; -// double dist = inner_prod(aux,aux); dist = sqrt(v); -// // std::cout << dist << std::endl; -// -// if(dist > max_disp && dist > 0.00) -// { -// double ratio = max_disp/dist; -// i->X() = xold + ratio * aux[0]; -// i->Y() = yold + ratio * aux[1]; -// i->Z() = zold + ratio * aux[2]; -// // std::cout << ratio << " " << aux << std::endl; -// // std::cout << ratio << " " << ratio * aux << std::endl; -// } - - - - - - } - } - KRATOS_CATCH("") - } - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - CoordinateLaplacianSmootherProcess& operator=(CoordinateLaplacianSmootherProcess const& rOther); - - - ///@} - -}; // Class CoordinateLaplacianSmootherProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - CoordinateLaplacianSmootherProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const CoordinateLaplacianSmootherProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_COORDINATE_LAPLACIAN_SMOOTHER_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/find_nodal_h_process.h b/applications/PFEMapplication/custom_processes/find_nodal_h_process.h deleted file mode 100644 index b5057d7ab12c..000000000000 --- a/applications/PFEMapplication/custom_processes/find_nodal_h_process.h +++ /dev/null @@ -1,353 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_FIND_NODAL_H_PROCESS_INCLUDED ) -#define KRATOS_FIND_NODAL_H_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. - calculate the nodal H for all the nodes depending on the min distance - of the neighbouring nodes. - - lonely nodes are given the average value of the H -*/ - -class FindNodalHProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of FindNodalHProcess - KRATOS_CLASS_POINTER_DEFINITION(FindNodalHProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - FindNodalHProcess(ModelPart& model_part) - : mr_model_part(model_part) - { - } - - /// Destructor. - virtual ~FindNodalHProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - virtual void Execute() - { - KRATOS_TRY - ModelPart::NodesContainerType& rNodes = mr_model_part.Nodes(); - // - - double havg = 0.00; - double h_nodes = 0; - - for(ModelPart::NodesContainerType::iterator in = rNodes.begin(); in!=rNodes.end(); in++) - { - if((in->GetValue(NEIGHBOUR_NODES)).size() != 0) - { - double xc = in->X(); - double yc = in->Y(); - double zc = in->Z(); - - double h = 1000.0; - for( WeakPointerVector< Node<3> >::iterator i = in->GetValue(NEIGHBOUR_NODES).begin(); - i != in->GetValue(NEIGHBOUR_NODES).end(); i++) - { - double x = i->X(); - double y = i->Y(); - double z = i->Z(); - double l = (x-xc)*(x-xc); - l += (y-yc)*(y-yc); - l += (z-zc)*(z-zc); - - //if(l>h) h = l; - if(lFastGetSolutionStepValue(NODAL_H) = h; - } - } - - //calculate average h - if(h_nodes == 0) - KRATOS_THROW_ERROR(std::logic_error,"no node has neighbours!!!!",""); - havg /= h_nodes; - - //set the h to the average to the nodes without neighours - for(ModelPart::NodesContainerType::iterator in = rNodes.begin(); in!=rNodes.end(); in++) - { - if((in->GetValue(NEIGHBOUR_NODES)).size() == 0) - { - in->FastGetSolutionStepValue(NODAL_H) = havg; - } - } - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "FindNodalHProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "FindNodalHProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - double m_min_h; - - - ///@} - ///@name Private Operators - ///@{ - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - FindNodalHProcess& operator=(FindNodalHProcess const& rOther); - - /// Copy constructor. - //FindNodalHProcess(FindNodalHProcess const& rOther); - - - ///@} - -}; // Class FindNodalHProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - FindNodalHProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const FindNodalHProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_FIND_NODAL_H_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/find_nodal_h_respecting_distance_process.h b/applications/PFEMapplication/custom_processes/find_nodal_h_respecting_distance_process.h deleted file mode 100644 index 90574eaaaa79..000000000000 --- a/applications/PFEMapplication/custom_processes/find_nodal_h_respecting_distance_process.h +++ /dev/null @@ -1,360 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_FIND_NODAL_H_RESPECTING_DISTANCE_PROCESS_INCLUDED ) -#define KRATOS_FIND_NODAL_H_RESPECTING_DISTANCE_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "includes/deprecated_variables.h" - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. - calculate the nodal H for all the nodes depending on the min distance - of the neighbouring nodes. - - lonely nodes are given the average value of the H -*/ - -class FindNodalHRespectingDistanceProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of FindNodalHProcess - KRATOS_CLASS_POINTER_DEFINITION(FindNodalHRespectingDistanceProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - FindNodalHRespectingDistanceProcess(ModelPart& model_part) - : mr_model_part(model_part) - { - } - - /// Destructor. - virtual ~FindNodalHRespectingDistanceProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - virtual void Execute() - { - KRATOS_TRY - ModelPart::NodesContainerType& rNodes = mr_model_part.Nodes(); - // - - double havg = 0.00; - double h_nodes = 0; - - for(ModelPart::NodesContainerType::iterator in = rNodes.begin(); in!=rNodes.end(); in++) - { - double max_distance = in->FastGetSolutionStepValue(DISTANCE); - double water_flag = in->GetSolutionStepValue(IS_WATER); -//KRATOS_WATCH(); - if( max_distance < .0035 && max_distance > 0.0 && water_flag == 1.0) - { - if((in->GetValue(NEIGHBOUR_NODES)).size() != 0) - { - - double xc = in->X(); - double yc = in->Y(); - double zc = in->Z(); - - double h = 1000.0; - for( WeakPointerVector< Node<3> >::iterator i = in->GetValue(NEIGHBOUR_NODES).begin(); - i != in->GetValue(NEIGHBOUR_NODES).end(); i++) - { - double x = i->X(); - double y = i->Y(); - double z = i->Z(); - double l = (x-xc)*(x-xc); - l += (y-yc)*(y-yc); - l += (z-zc)*(z-zc); - - //if(l>h) h = l; - if(lFastGetSolutionStepValue(NODAL_H) = h; - } - } - } - - //calculate average h -// if(h_nodes == 0) -// KRATOS_THROW_ERROR(std::logic_error,"no node has neighbours!!!!",""); -// havg /= h_nodes; - - //set the h to the average to the nodes without neighours -// for(ModelPart::NodesContainerType::iterator in = rNodes.begin(); in!=rNodes.end(); in++) -// { -// if((in->GetValue(NEIGHBOUR_NODES)).size() == 0) -// { -// in->FastGetSolutionStepValue(NODAL_H) = havg; -// } -// } - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "FindNodalHProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "FindNodalHProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - double m_min_h; - - - ///@} - ///@name Private Operators - ///@{ - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - FindNodalHRespectingDistanceProcess& operator=(FindNodalHRespectingDistanceProcess const& rOther); - - /// Copy constructor. - //FindNodalHProcess(FindNodalHProcess const& rOther); - - - ///@} - -}; // Class FindNodalHProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - FindNodalHRespectingDistanceProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const FindNodalHRespectingDistanceProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_FIND_NODAL_H_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/lagrangian_inlet_process.h b/applications/PFEMapplication/custom_processes/lagrangian_inlet_process.h deleted file mode 100644 index 84aa778a581b..000000000000 --- a/applications/PFEMapplication/custom_processes/lagrangian_inlet_process.h +++ /dev/null @@ -1,405 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_LAGRANGIAN_INLET_PROCESS_INCLUDED ) -#define KRATOS_LAGRANGIAN_INLET_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "custom_utilities/adaptivity_utilities.h" - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -//adds nodes to the inlet boundary ... every "insertion_time_step" time -/** Detail class definition. -*/ - -class LagrangianInletProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of LagrangianInletProcess - KRATOS_CLASS_POINTER_DEFINITION(LagrangianInletProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - LagrangianInletProcess(ModelPart& model_part, double insertion_time_step) - : mr_model_part(model_part) - { - KRATOS_TRY - minsertion_time = 0.00; - minsertion_time_step = insertion_time_step; - KRATOS_CATCH("") - } - - /// Destructor. - virtual ~LagrangianInletProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - virtual void Execute() - { - KRATOS_TRY; - - double time = mr_model_part.GetProcessInfo()[TIME]; - - if(minsertion_time == 0.00) - { - minsertion_time_step = EstimateInsertionTime(); - minsertion_time = time + minsertion_time_step; - } - - if(time >= minsertion_time) - { - - //detecting number of new nodes - int new_nodes_number = 0; - for(ModelPart::NodesContainerType::iterator in = mr_model_part.NodesBegin(); in!=mr_model_part.NodesEnd(); in++) - { - if(in->FastGetSolutionStepValue(IS_LAGRANGIAN_INLET) == 1) - new_nodes_number += 1; - } - - if(new_nodes_number != 0) - { - //allocating the memory needed - int old_size = mr_model_part.Nodes().size(); - (mr_model_part.Nodes()).reserve(old_size + new_nodes_number); - - for(int i = 0; iFastGetSolutionStepValue(IS_LAGRANGIAN_INLET) == 1) - { - //first of all set the node as normal fluid (not structure) - in->FastGetSolutionStepValue(IS_STRUCTURE) = 0; - in->FastGetSolutionStepValue(IS_BOUNDARY) = 0; - in->FastGetSolutionStepValue(IS_LAGRANGIAN_INLET) = 0; - in->Free(VELOCITY_X); - in->Free(VELOCITY_Y); - in->Free(VELOCITY_Z); - in->Free(FRACT_VEL_X); - in->Free(FRACT_VEL_Y); - in->Free(FRACT_VEL_Z); - - //make a copy of the - Node<3>::Pointer new_node = AdaptivityUtils::AddNode(in->X(),in->Y(),in->Z(),mr_model_part); - array_1d& vnew = new_node->FastGetSolutionStepValue(VELOCITY); - const array_1d& v = in->FastGetSolutionStepValue(VELOCITY); - noalias(vnew) = v; - new_node->FastGetSolutionStepValue(VELOCITY,1) = in->FastGetSolutionStepValue(VELOCITY,1); - new_node->FastGetSolutionStepValue(PRESSURE) = in->FastGetSolutionStepValue(PRESSURE); - new_node->FastGetSolutionStepValue(CONV_PROJ) = in->FastGetSolutionStepValue(CONV_PROJ); - new_node->FastGetSolutionStepValue(PRESS_PROJ) = in->FastGetSolutionStepValue(PRESS_PROJ); - new_node->Fix(VELOCITY_X); - new_node->Fix(VELOCITY_Y); - new_node->Fix(VELOCITY_Z); - new_node->Fix(FRACT_VEL_X); - new_node->Fix(FRACT_VEL_Y); - new_node->Fix(FRACT_VEL_Z); - new_node->pAddDof(PRESSURE); - - new_node->FastGetSolutionStepValue(IS_BOUNDARY) = 1; - new_node->FastGetSolutionStepValue(IS_STRUCTURE) = 1; - new_node->FastGetSolutionStepValue(IS_LAGRANGIAN_INLET) = 1; - double nodal_h = in->FastGetSolutionStepValue(NODAL_H); - new_node->FastGetSolutionStepValue(NODAL_H) = nodal_h; - } - } - minsertion_time_step = EstimateInsertionTime(); - KRATOS_WATCH(minsertion_time_step); - - //update the time for the next insertion - minsertion_time = time + minsertion_time_step; - - } - } - - - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "LagrangianInletProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "LagrangianInletProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - double minsertion_time_step; - double minsertion_time; - - - ///@} - ///@name Private Operators - ///@{ - double EstimateInsertionTime() - { - KRATOS_TRY - - double dt_estimate = 100.0; - - for(ModelPart::NodesContainerType::iterator in = mr_model_part.NodesBegin(); in!=mr_model_part.NodesEnd(); in++) - { - if(in->FastGetSolutionStepValue(IS_LAGRANGIAN_INLET) == 1) - { - const array_1d& v = in->FastGetSolutionStepValue(VELOCITY); - double nodal_h = in->FastGetSolutionStepValue(NODAL_H); - - //estimating the next time step - double normv = norm_2(v); - double dtcandidate = nodal_h / normv; - if( dtcandidate < dt_estimate) - dt_estimate = dtcandidate; - } - } - - return dt_estimate; - - KRATOS_CATCH(""); - } - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - LagrangianInletProcess& operator=(LagrangianInletProcess const& rOther); - - - ///@} - -}; // Class LagrangianInletProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - LagrangianInletProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const LagrangianInletProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_LAGRANGIAN_INLET_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/mark_bad_elements_process.h b/applications/PFEMapplication/custom_processes/mark_bad_elements_process.h deleted file mode 100755 index 40c99971da76..000000000000 --- a/applications/PFEMapplication/custom_processes/mark_bad_elements_process.h +++ /dev/null @@ -1,381 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// this process marks distorted fluid elements and their direct neighbours - -#if !defined(KRATOS_MARK_BAD_ELEMENTS_PROCESS_INCLUDED ) -#define KRATOS_MARK_BAD_ELEMENTS_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "custom_utilities/geometry_utilities2D.h" -#include "custom_elements/updated_lagrangian_fluid.h" - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. - Update the PRESSURE_FORCE on the nodes - - -*/ - -class MarkBadElementsProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of PushStructureProcess - KRATOS_CLASS_POINTER_DEFINITION(MarkBadElementsProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - MarkBadElementsProcess(ModelPart& model_part) - : mr_model_part(model_part) - { - } - - /// Destructor. - virtual ~MarkBadElementsProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - virtual void Execute() - { - KRATOS_TRY - for(ModelPart::ElementsContainerType::const_iterator im = mr_model_part.ElementsBegin(); in!=mr_model_part.ElementsEnd(); in++) - { - double x0 = im.X(); - double x1 = im.X(); - double x2 = pgeom[2].X(); - - double y0 = pgeom[0].Y(); - double y1 = pgeom[1].Y(); - double y2 = pgeom[2].Y(); - - /*if( ((y0<-0.1) || (y1<-0.1 ) || (y2<-0.1 )) && (x0>1.1 || x1>1.1 || x2>1.1 )) - { - return false; - }*/ - - msJ(0,0)=2.0*(x1-x0); - msJ(0,1)=2.0*(y1-y0); - msJ(1,0)=2.0*(x2-x0); - msJ(1,1)=2.0*(y2-y0); - - - double detJ = msJ(0,0)*msJ(1,1)-msJ(0,1)*msJ(1,0); - - msJinv(0,0) = msJ(1,1); - msJinv(0,1) = -msJ(0,1); - msJinv(1,0) = -msJ(1,0); - msJinv(1,1) = msJ(0,0); - - bounded_matrix check; - - - if(detJ < 1e-12) - { - //std::cout << "detJ = " << detJ << std::endl; - ////mark as boundary - pgeom[0].GetSolutionStepValue(IS_BOUNDARY) = 1; - pgeom[1].GetSolutionStepValue(IS_BOUNDARY) = 1; - pgeom[2].GetSolutionStepValue(IS_BOUNDARY) = 1; - return false; - } - - else - { - - double x0_2 = x0*x0 + y0*y0; - double x1_2 = x1*x1 + y1*y1; - double x2_2 = x2*x2 + y2*y2; - - //finalizing the calculation of the inverted matrix - //std::cout<<"MATR INV"<> (std::istream& rIStream, - MarkBadElementsProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const MarkBadElementsProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_MARK_BAD_ELEMENTS_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/move_mesh_process.h b/applications/PFEMapplication/custom_processes/move_mesh_process.h deleted file mode 100644 index 39c8e46eab22..000000000000 --- a/applications/PFEMapplication/custom_processes/move_mesh_process.h +++ /dev/null @@ -1,347 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_MOVE_MESH_PROCESS_INCLUDED ) -#define KRATOS_MOVE_MESH_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. -*/ - -class MoveMeshProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of MoveMeshProcess - KRATOS_CLASS_POINTER_DEFINITION(MoveMeshProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - MoveMeshProcess(ModelPart& model_part) - : mr_model_part(model_part) - { - KRATOS_TRY - KRATOS_CATCH("") - } - - /// Destructor. - virtual ~MoveMeshProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - virtual void Execute() - { - KRATOS_TRY; - - double dt = mr_model_part.GetProcessInfo()[DELTA_TIME]; - - //temporarily save the incremental displacement in the displacement variable - for(ModelPart::NodeIterator i = mr_model_part.NodesBegin() ; - i != mr_model_part.NodesEnd() ; ++i) - { - const array_1d& disp = i->FastGetSolutionStepValue(DISPLACEMENT); - i->X() = i->X0() + disp[0]; - i->Y() = i->Y0() + disp[1]; - i->Z() = i->Z0() + disp[2]; - - array_1d& mesh_vel = i->FastGetSolutionStepValue(MESH_VELOCITY); - noalias(mesh_vel) = disp; - noalias(mesh_vel) -= i->FastGetSolutionStepValue(DISPLACEMENT,1); - mesh_vel /= dt; - - } - - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "MoveMeshProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "MoveMeshProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - int mNumberOfLoops; - - - ///@} - ///@name Private Operators - ///@{ - void SmoothingLoopOnNodes() - { - KRATOS_TRY - //performs a laplacian smoothing over the incremental displacements - for(ModelPart::NodeIterator i = mr_model_part.NodesBegin() ; - i != mr_model_part.NodesEnd() ; ++i) - { - WeakPointerVector< Node<3> >& neighbours = (i->GetValue(NEIGHBOUR_NODES)); - //WeakPointerVector< Element >& el_neigh = (i->GetValue(NEIGHBOUR_ELEMENTS)); - - - double nneigh = neighbours.size(); - if( nneigh != 0.00 && //if it has neighoburs - i->GetSolutionStepValue(IS_BOUNDARY) == 0 ) //and it is not on the boundary - { - array_1d& disp = i->FastGetSolutionStepValue(DISPLACEMENT); - for(WeakPointerVector< Node<3> >::iterator ii = neighbours.begin() ; - ii != neighbours.end() ; ++ii) - { - noalias(disp) += ii->FastGetSolutionStepValue(DISPLACEMENT); - } - disp/=nneigh; - } - } - KRATOS_CATCH("") - } - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - MoveMeshProcess& operator=(MoveMeshProcess const& rOther); - - /// Copy constructor. - //MoveMeshProcess(MoveMeshProcess const& rOther); - - - ///@} - -}; // Class MoveMeshProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - MoveMeshProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const MoveMeshProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_MOVE_MESH_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/pressure_contribution_process.h b/applications/PFEMapplication/custom_processes/pressure_contribution_process.h deleted file mode 100755 index 7c6e8c157e51..000000000000 --- a/applications/PFEMapplication/custom_processes/pressure_contribution_process.h +++ /dev/null @@ -1,288 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-01-23 15:38:00 $ -// Revision: $Revision: 1.1 $ 20 October 2006 CLEAN VERSION -// -// -// THIS PROCESS is INVENTED in order to CALCULATE THE VOLUMETRIC force and -//STORE it node-wise. that is the term Integral(BdeltaSvolumetric). -// this term will be later added to the RHS vector as a prestress!!! -// this is done inside the pressure_contribution.cpp - -#if !defined(KRATOS_PRESSURE_CONTRIBUTION_PROCESS_INCLUDED ) -#define KRATOS_PRESSURE_CONTRIBUTION_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "utilities/geometry_utilities.h" -#include "custom_elements/updated_lagrangian_fluid.h" -#include "PFEM_application.h" - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. - Update the PRESSURE_FORCE on the nodes - - -*/ - -class PressureContributionProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of PressureContributionProcess - KRATOS_CLASS_POINTER_DEFINITION(PressureContributionProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - PressureContributionProcess(ModelPart& model_part) - : mr_model_part(model_part) - { - } - - /// Destructor. - virtual ~PressureContributionProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - virtual void Execute() - { - KRATOS_TRY - - ProcessInfo& proc_info = mr_model_part.GetProcessInfo(); - array_1d dummy; - //first initialize the pressure force to the old value - - for(ModelPart::NodesContainerType::iterator in = mr_model_part.NodesBegin() ; - in != mr_model_part.NodesEnd() ; ++in) - { - noalias(in->FastGetSolutionStepValue(PRESSURE_FORCE)) - = in->FastGetSolutionStepValue(PRESSURE_FORCE,1); - } - - //and now add the increment due to the current solution step displacement - for(ModelPart::ElementsContainerType::iterator im = mr_model_part.ElementsBegin() ; - im != mr_model_part.ElementsEnd() ; ++im) - { - im->Calculate(PRESSURE_FORCE, dummy, proc_info); - } - - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "PressureContributionProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "PressureContributionProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - double m_min_h; - - - ///@} - ///@name Private Operators - ///@{ - - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. -// PressureContributionProcess& operator=(PressureContributionProcess const& rOther); - - /// Copy constructor. -// PressureContributionProcess(PressureContributionProcess const& rOther); - - - ///@} - -}; // Class PressureContributionProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - PressureContributionProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const PressureContributionProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_PRESSURE_CONTRIBUTION_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/ulf_apply_bc_process.h b/applications/PFEMapplication/custom_processes/ulf_apply_bc_process.h deleted file mode 100755 index ee66ecf96bbe..000000000000 --- a/applications/PFEMapplication/custom_processes/ulf_apply_bc_process.h +++ /dev/null @@ -1,290 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-01-23 15:38:00 $ -// Revision: $Revision: 1.1 $ -// -// this process save structural elements in a separate list - -#if !defined(KRATOS_ULF_APPLY_BC_PROCESS_INCLUDED ) -#define KRATOS_ULF_APPLY_BC_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "custom_utilities/geometry_utilities2D.h" -#include "custom_elements/updated_lagrangian_fluid.h" - - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. - Update the PRESSURE_FORCE on the nodes - - -*/ - -class UlfApplyBCProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of PushStructureProcess - KRATOS_CLASS_POINTER_DEFINITION(UlfApplyBCProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - UlfApplyBCProcess(ModelPart& model_part) - : mr_model_part(model_part) - { - } - - /// Destructor. - virtual ~UlfApplyBCProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - Execute(); - } - - - ///@} - ///@name Operations - ///@{ - - virtual void Execute() - { - KRATOS_TRY - for(ModelPart::NodesContainerType::const_iterator in = mr_model_part.NodesBegin(); in!=mr_model_part.NodesEnd(); in++) - { - //marking wet nodes - if(in->FastGetSolutionStepValue(IS_STRUCTURE) ) - if( (in->GetValue(NEIGHBOUR_ELEMENTS)).size() != 0) - in->FastGetSolutionStepValue(IS_FLUID) = 1.0; - else //it is not anymore of fluid - in->FastGetSolutionStepValue(IS_FLUID) = 0.0; - //marking as free surface the lonely nodes - else if( (in->GetValue(NEIGHBOUR_ELEMENTS)).size() == 0) - in->FastGetSolutionStepValue(IS_BOUNDARY) = 1.0; - } - - //identify the free surface - for(ModelPart::NodeIterator i = mr_model_part.NodesBegin() ; - i != mr_model_part.NodesEnd() ; ++i) - { - //reset the free surface - i->FastGetSolutionStepValue(IS_FREE_SURFACE) = 0; - //identify the free surface and fix the pressure accordingly - if( i->FastGetSolutionStepValue(IS_BOUNDARY) != 0 - && - i->FastGetSolutionStepValue(IS_STRUCTURE) == 0) - { - i->FastGetSolutionStepValue(IS_FREE_SURFACE) = 1; - } - } - - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "UlfApplyBCProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "UlfApplyBCProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - - ///@} - ///@name Private Operators - ///@{ - - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. -// UlfApplyBCProcess& operator=(UlfApplyBCProcess const& rOther); - - /// Copy constructor. -// UlfApplyBCProcess(UlfApplyBCProcess const& rOther); - - - ///@} - -}; // Class UlfApplyBCProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - UlfApplyBCProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const UlfApplyBCProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_ULF_APPLY_BC_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_processes/ulf_time_step_dec_process.h b/applications/PFEMapplication/custom_processes/ulf_time_step_dec_process.h deleted file mode 100644 index b45a89287ee8..000000000000 --- a/applications/PFEMapplication/custom_processes/ulf_time_step_dec_process.h +++ /dev/null @@ -1,327 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-01-16 17:25:31 $ -// Revision: $Revision: 1.1 $ -// -// NOW FOR 2D ONLY!!! WRITE a 3D version of it!!!! - -#if !defined(KRATOS_ULF_TIME_STEP_DEC_PROCESS_INCLUDED ) -#define KRATOS_ULF_TIME_STEP_DEC_PROCESS_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "utilities/geometry_utilities.h" - -//to compute the determinant -#include "utilities/math_utils.h" - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. - Update the PRESSURE_FORCE on the nodes - - -*/ - -class UlfTimeStepDecProcess - : public Process -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of PushStructureProcess - KRATOS_CLASS_POINTER_DEFINITION(UlfTimeStepDecProcess); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - UlfTimeStepDecProcess(ModelPart& model_part) - : mr_model_part(model_part) - { - } - - /// Destructor. - virtual ~UlfTimeStepDecProcess() - { - } - - - ///@} - ///@name Operators - ///@{ - - void operator()() - { - - } - - - ///@} - ///@name Operations - ///@{ - - double EstimateDeltaTime(const double dt_max, const double domain_size) - { - double estimated_dt = 0.00; - if(domain_size == 2) - estimated_dt = EstimateDeltaTimeTemplated<2>(dt_max); - else - estimated_dt = EstimateDeltaTimeTemplated<3>(dt_max); - return estimated_dt; - - } - - template< int TDim> - double EstimateDeltaTimeTemplated(const double dt_max) - { - KRATOS_TRY - - double deltatime_new; - double deltatime = dt_max; - boost::numeric::ublas::bounded_matrix aux; - //this is for 2D only - boost::numeric::ublas::bounded_matrix DN_DX; - boost::numeric::ublas::bounded_matrix Dv_dx; - boost::numeric::ublas::bounded_matrix J; - boost::numeric::ublas::bounded_matrix I = IdentityMatrix(TDim,TDim); - boost::numeric::ublas::bounded_matrix Zero = ZeroMatrix(TDim,TDim); - array_1d N; - double Area; - double detJ; - - - for(ModelPart::ElementsContainerType::iterator i = mr_model_part.ElementsBegin(); - i!=mr_model_part.ElementsEnd(); i++) - { - //calculating the actual Jacobian - for(unsigned int iii = 0; iii < i->GetGeometry().size(); iii++) - { - const array_1d& v = i->GetGeometry()[iii].FastGetSolutionStepValue(VELOCITY); - for(unsigned int j=0; j GetGeometry(),DN_DX, N, Area); - - if (Area<=0) - KRATOS_THROW_ERROR(std::logic_error,"negative area at the moment of estimating the time step",""); - noalias(Dv_dx) = prod(aux,DN_DX); - noalias(J) = I + deltatime*Dv_dx; - - detJ = MathUtils::Det(J); - //std::cout<<"DETJ is "<::Det(J); - if (detJ<=0) - { - deltatime_new=deltatime/(1-detJ); //x=-b/k - deltatime=deltatime_new; - } - - } - } - - return deltatime; - KRATOS_CATCH("") - - - } - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "UlfTimeStepDecProcess"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "UlfTimeStepDecProcess"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - ///@{ - ModelPart& mr_model_part; - - ///@} - ///@name Private Operators - ///@{ - - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. -// UlfTimeStepDecProcess& operator=(UlfTimeStepDecProcess const& rOther); - - /// Copy constructor. -// UlfTimeStepDecProcess(UlfTimeStepDecProcess const& rOther); - - - ///@} - -}; // Class UlfTimeStepDecProcess - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - UlfTimeStepDecProcess& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const UlfTimeStepDecProcess& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_ULF_TIME_STEP_DEC_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_python/add_custom_io_to_python.cpp b/applications/PFEMapplication/custom_python/add_custom_io_to_python.cpp deleted file mode 100644 index c302ca76988e..000000000000 --- a/applications/PFEMapplication/custom_python/add_custom_io_to_python.cpp +++ /dev/null @@ -1,169 +0,0 @@ -/* -============================================================================== -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNER. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last modified by: $Author: kazem $ -// Date: $Date: 2008-07-30 12:30:48 $ -// Revision: $Revision: 1.1 $ -// -// - - -// System includes - -// External includes -#include - - -// Project includes -#include "includes/define.h" -// #include "includes/datafile_io.h" -// #include "includes/gid_io.h" -#include "custom_utilities/twofluid_gid_io.h" -#include "python/add_io_to_python.h" -#include "custom_python/add_custom_io_to_python.h" - -namespace Kratos -{ -namespace Python -{ -typedef GidIO GidIOType; -typedef GidIO<> GidIOBaseType; - -void WriteNodeMesh( GidIOType& dummy, GidIOType::MeshType& rThisMesh ) -{ - KRATOS_WATCH("writing Node Mesh"); - dummy.WriteNodeMesh( rThisMesh ); -} -void WriteMesh( GidIOType& dummy, GidIOType::MeshType& rThisMesh ) -{ -// dummy.WriteMesh( rThisMesh ); -} - -void DoublePrintOnGaussPoints( GidIOType& dummy, const Variable& rVariable, - ModelPart& r_model_part, double SolutionTag ) -{ - dummy.PrintOnGaussPoints( rVariable, r_model_part, SolutionTag ); -} - -void VectorPrintOnGaussPoints( GidIOType& dummy, const Variable& rVariable, - ModelPart& r_model_part, double SolutionTag ) -{ - dummy.PrintOnGaussPoints( rVariable, r_model_part, SolutionTag ); -} - -void MatrixPrintOnGaussPoints( GidIOType& dummy, const Variable& rVariable, - ModelPart& r_model_part, double SolutionTag ) -{ - dummy.PrintOnGaussPoints( rVariable, r_model_part, SolutionTag ); -} - -void (GidIOType::*pointer_to_double_write_nodal_results)( - Variable const& rVariable, - GidIOType::NodesContainerType& rNodes, double SolutionTag, - std::size_t SolutionStepNumber ) = &GidIOType::WriteNodalResults; -void (GidIOType::*pointer_to_array1d_write_nodal_results)( - Variable > const& rVariable, - GidIOType::NodesContainerType& rNodes, double SolutionTag, - std::size_t SolutionStepNumber) = &GidIOType::WriteNodalResults; - - -// void (GidIOType::*pointer_to_double_write_nodal_results)( Variable const& rVariable, -// GidIOType::NodesContainerType& rNodes, double SolutionTag, -// std::size_t SolutionStepNumber ) = &GidIO::WriteNodalResults; -// void (GidIOType::*pointer_to_array1d_write_nodal_results)( -// Variable > const& rVariable, GidIOType::NodesContainerType& rNodes, -// double SolutionTag, std::size_t SolutionStepNumber) = &GidIOType::WriteNodalResults; - -// void (GidIOType::*pointer_to_double_print_on_gauss_points)(const Variable& rVariable, -// ModelPart& r_model_part, double SolutionTag) -// = &GidIOType::PrintOnGaussPoints; -// void (GidIOType::*pointer_to_matrix_print_on_gauss_points)(const Variable& rVariable, -// ModelPart& r_model_part, double SolutionTag) -// = &GidIOType::PrintOnGaussPoints; -// void (GidIOType::*pointer_to_vector_print_on_gauss_points)(const Variable& rVariable, -// ModelPart& r_model_part, double SolutionTag) -// = &GidIOType::PrintOnGaussPoints; - -void AddCustomIOToPython() -{ - - - using namespace boost::python; - - class_, boost::noncopyable>( - "TwoFluidGidIO",init()) - //.def(init()) - .def("WriteMesh",WriteMesh) - .def("WriteNodeMesh",WriteNodeMesh) - - .def("InitializeMesh",&GidIOType::InitializeMesh) - .def("FinalizeMesh",&GidIOType::FinalizeMesh) - - .def("InitializeResults",&GidIOType::InitializeResults) - .def("FinalizeResults",&GidIOType::FinalizeResults) - - .def("WriteNodalResults",pointer_to_double_write_nodal_results) - .def("WriteNodalResults",pointer_to_array1d_write_nodal_results) -// .def("WriteNodalResults",pointer_to_vector_write_nodal_results) -// .def("WriteNodalResults",pointer_to_matrix_write_nodal_results) - -// .def("PrintOnGaussPoints", pointer_to_double_print_on_gauss_points) -// .def("PrintOnGaussPoints", pointer_to_vector_print_on_gauss_points) -// .def("PrintOnGaussPoints", pointer_to_matrix_print_on_gauss_points) - .def("PrintOnGaussPoints", DoublePrintOnGaussPoints) - .def("PrintOnGaussPoints", VectorPrintOnGaussPoints) - .def("PrintOnGaussPoints", MatrixPrintOnGaussPoints) -// .def("CondPrintOnGaussPoints", pointer_to_double_cond_print_on_gauss_points) - - .def("Flush",&GidIOType::Flush) - .def("CloseResultFile",&GidIOType::CloseResultFile) - //.def("",&DatafileIO::) - //.def(self_ns::str(self)) - ; - -} -} // namespace Python. - -} // Namespace Kratos - - diff --git a/applications/PFEMapplication/custom_python/add_custom_io_to_python.h b/applications/PFEMapplication/custom_python/add_custom_io_to_python.h deleted file mode 100644 index 47539745e505..000000000000 --- a/applications/PFEMapplication/custom_python/add_custom_io_to_python.h +++ /dev/null @@ -1,75 +0,0 @@ -/* -============================================================================== -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNER. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: kazem $ -// Date: $Date: 2008-07-30 12:30:55 $ -// Revision: $Revision: 1.1 $ -// -// - - -#if !defined(KRATOS_ADD_CUSTOM_IO_TO_PYTHON_H_INCLUDED ) -#define KRATOS_ADD_CUSTOM_IO_TO_PYTHON_H_INCLUDED - - - -// System includes - - -// External includes - - -// Project includes -#include "includes/define.h" - - -namespace Kratos -{ - -namespace Python -{ - -void AddCustomIOToPython(); - -} // namespace Python. - -} // namespace Kratos. - -#endif // KRATOS_ADD_CUSTOM_IO_TO_PYTHON_H_INCLUDED defined diff --git a/applications/PFEMapplication/custom_python/add_custom_utilities_to_python.cpp b/applications/PFEMapplication/custom_python/add_custom_utilities_to_python.cpp deleted file mode 100644 index 5e12eb80beee..000000000000 --- a/applications/PFEMapplication/custom_python/add_custom_utilities_to_python.cpp +++ /dev/null @@ -1,219 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last modified by: $Author: antonia $ -// Date: $Date: 2008-03-05 09:39:14 $ -// Revision: $Revision: 1.6 $ -// -// - - -// System includes - -// External includes -#include - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "custom_python/add_custom_utilities_to_python.h" -#include "custom_utilities/pfem_utilities.h" -#include "custom_utilities/normal_to_wall_calculation_utils.h" -#include "custom_utilities/volume_correction_utils.h" -#include "custom_utilities/lagrangian_utilities.h" -#include "custom_utilities/nist_utilities.h" -#include "custom_utilities/erosion_utilities.h" -#include "custom_utilities/drag_utilities.h" -#include "custom_utilities/binbased_seepage_coupled_mapping.h" -#include "custom_utilities/binbased_DEM_ULF_coupled_mapping.h" -//#include "custom_utilities/streamline_utils.h" - -#include "spaces/ublas_space.h" -#include "linear_solvers/linear_solver.h" -#include "custom_utilities/lagrangian_euler_solver.h" -#include "custom_utilities/exact_dt_estimate_utilities.h" - -namespace Kratos -{ - -namespace Python -{ -/*void GenerateModelPart(NistUtils& NistUtils,ModelPart& origin_model_part,ModelPart& destination_model_part,unsigned int domain_size ) -{ - if(domain_size == 2) - { - NistUtils.GenerateModelPart(origin_model_part, destination_model_part, - KratosComponents::Get("ConvDiff2D"), - KratosComponents::Get("ThermalFace2D") ); - } - else if(domain_size == 3) - { - NistUtils.GenerateModelPart(origin_model_part, destination_model_part, - KratosComponents::Get("ConvDiff3D"), - KratosComponents::Get("ThermalFace3D") ); - } -}*/ - -void AddCustomUtilitiesToPython() -{ - using namespace boost::python; - - class_("PfemUtils", init<>()) - .def("ApplyBoundaryConditions",&PfemUtils::ApplyBoundaryConditions) - .def("ApplyMinimalPressureConditions",&PfemUtils::ApplyMinimalPressureConditions) - .def("EstimateDeltaTime",&PfemUtils::EstimateDeltaTime) - .def("MarkOuterNodes",&PfemUtils::MarkOuterNodes) - .def("CalculateSpatialALEAcceleration2D",&PfemUtils::CalculateSpatialALEAcceleration<2>) - .def("CalculateSpatialALEAcceleration3D",&PfemUtils::CalculateSpatialALEAcceleration<3>) - .def("QuasiLagrangianMove",&PfemUtils::QuasiLagrangianMove) - .def("Predict",&PfemUtils::Predict) - .def("MoveLonelyNodes",&PfemUtils::MoveLonelyNodes) - .def("CalculateVolume",&PfemUtils::CalculateVolume) - .def("CalculateNodalMass",&PfemUtils::CalculateNodalMass) - .def("IdentifyFluidNodes",&PfemUtils::IdentifyFluidNodes) - .def("ReduceTimeStep",&PfemUtils::ReduceTimeStep) - .def("MarkExcessivelyCloseNodes",&PfemUtils::MarkExcessivelyCloseNodes) - .def("MarkNodesTouchingWall",&PfemUtils::MarkNodesTouchingWall) - .def("MarkNodesTouchingInterface",&PfemUtils::MarkNodesTouchingInterface) - .def("InterfaceDetecting",&PfemUtils::InterfaceDetecting) - .def("ChangeWallWaterFlag",&PfemUtils::ChangeWallWaterFlag) - .def("ChangeInterfaceWaterFlag",&PfemUtils::ChangeInterfaceWaterFlag) - .def("ColourAirWaterElement",&PfemUtils::ColourAirWaterElement) - .def("AssignNearBoundaryH",&PfemUtils::AssignNearBoundaryH) - .def("MoveNodes",&PfemUtils::MoveNodes) - .def("AssignMeshVelocity",&PfemUtils::AssignMeshVelocity) - .def("CFLdeltaT",&PfemUtils::CFLdeltaT) - .def("ExplicitDeltaT",&PfemUtils::ExplicitDeltaT) - .def("CheckInvertedElements",&PfemUtils::CheckInvertedElements) - - ; - - class_("NormalToWallCalculationUtils", init<>()) - .def("CalculateNormalToWall",&NormalToWallCalculationUtils::CalculateNormalToWall) - ; - - class_("VolumeCorrectionUtils", init<>()) - .def("CorrectVolume",&VolumeCorrectionUtils::CorrectVolume) - ; - - class_("LagrangianUtils", init<>()) - .def("ExplicitLagrangianPrediction",&LagrangianUtils::ExplicitLagrangianPrediction) - .def("ImplicitLagrangianPrediction",&LagrangianUtils::ImplicitLagrangianPrediction) - .def("CalculateStep1DisplacementCorrection",&LagrangianUtils::CalculateStep1DisplacementCorrection) - .def("CalculateFinalDisplacementCorrection",&LagrangianUtils::CalculateFinalDisplacementCorrection) - ; - - class_("NistUtils", init<>()) - //.def("GenerateModelPart",GenerateModelPart) - .def("ApplyInitialTemperature",&NistUtils::ApplyInitialTemperature) - .def("FindFluidLevel",&NistUtils::FindFluidLevel) - ; - - class_, boost::noncopyable> ("ErosionUtils2D", init< >()) - .def("CheckErosionableNodes",&ErosionUtils<2>::CheckErosionableNodes) - .def("SetErosionableNodes", &ErosionUtils<2>::SetErosionableNodes) - ; - - class_, boost::noncopyable> ("ErosionUtils3D", init< >()) - .def("CheckErosionableNodes",&ErosionUtils<3>::CheckErosionableNodes) - .def("SetErosionableNodes", &ErosionUtils<3>::SetErosionableNodes) - ; - - typedef UblasSpace SparseSpaceType; - typedef UblasSpace LocalSpaceType; - typedef LinearSolver LinearSolverType; - - class_< LagrangianEulerSolver< 2, SparseSpaceType, LinearSolverType >, boost::noncopyable > ("LagrangianEulerSolver2D", init< >() ) - .def("Predict",&LagrangianEulerSolver< 2, SparseSpaceType, LinearSolverType >::Predict) - .def("SolveConvectionStep",&LagrangianEulerSolver< 2, SparseSpaceType, LinearSolverType >::SolveConvectionStep) - .def("ConstructLaplacianSystem",&LagrangianEulerSolver< 2, SparseSpaceType, LinearSolverType >::ConstructLaplacianSystem) - .def("BuildAndSolveLaplacianSystem",&LagrangianEulerSolver< 2, SparseSpaceType, LinearSolverType >::BuildAndSolveLaplacianSystem) - .def("ClearLaplacianSystem",&LagrangianEulerSolver< 2, SparseSpaceType, LinearSolverType >::ClearLaplacianSystem) - ; - - - class_("ExactDtEstimateUtilities", init<>()) - .def("CubicExactDt",&ExactDtEstimateUtilities::CubicExactDt) - ; - - class_("DragUtils", init<>()) - .def("CalculateFluidDrag",&DragUtils::CalculateFluidDrag) - .def("AddDrag",&DragUtils::AddDrag) - ; - - class_ >("BinBasedSeepageCoupledMapping2D", init< >()) - .def("InterpolationFromFixedMesh", &BinBasedSeepageCoupledMapping < 2 > ::InterpolationFromFixedMesh) - .def("InterpolationFromMovingMesh", &BinBasedSeepageCoupledMapping < 2 > ::InterpolationFromMovingMesh) - ; - - class_ >("BinBasedSeepageCoupledMapping3D", init< >()) - .def("InterpolationFromFixedMesh", &BinBasedSeepageCoupledMapping < 3 > ::InterpolationFromFixedMesh) - .def("InterpolationFromMovingMesh", &BinBasedSeepageCoupledMapping < 3 > ::InterpolationFromMovingMesh) - ; - - class_ >("BinBasedDEMULFCoupledMapping2D", init< >()) - .def("InterpolationFromFluidMesh", &BinBasedDEMULFCoupledMapping < 2 > ::InterpolationFromFluidMesh) - .def("InterpolationFromDEMMesh", &BinBasedDEMULFCoupledMapping < 2 > ::InterpolationFromDEMMesh) - ; - - class_ >("BinBasedDEMULFCoupledMapping3D", init< >()) - .def("InterpolationFromFluidMesh", &BinBasedDEMULFCoupledMapping < 3 > ::InterpolationFromFluidMesh) - .def("InterpolationFromDEMMesh", &BinBasedDEMULFCoupledMapping < 3 > ::InterpolationFromDEMMesh) - ; - -// class_, boost::noncopyable> ("StreamlineUtils2D", init< >()) -// .def("LagrangianMoveBackAndForward",&StreamlineUtils<2>::LagrangianMoveBackAndForward) -// ; - - -} - - - - - -} // namespace Python. - -} // Namespace Kratos - diff --git a/applications/PFEMapplication/custom_python/add_custom_utilities_to_python.h b/applications/PFEMapplication/custom_python/add_custom_utilities_to_python.h deleted file mode 100644 index ca25804954da..000000000000 --- a/applications/PFEMapplication/custom_python/add_custom_utilities_to_python.h +++ /dev/null @@ -1,78 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_ADD_UTILITIES_TO_PYTHON_H_INCLUDED ) -#define KRATOS_ADD_UTILITIES_TO_PYTHON_H_INCLUDED - - - -// System includes - - -// External includes - - -// Project includes -#include "includes/define.h" - - -namespace Kratos -{ - -namespace Python -{ - -void AddCustomUtilitiesToPython(); - -} // namespace Python. - -} // namespace Kratos. - -#endif // KRATOS_ADD_UTILITIES_TO_PYTHON_H_INCLUDED defined diff --git a/applications/PFEMapplication/custom_python/add_meshers_to_python.cpp b/applications/PFEMapplication/custom_python/add_meshers_to_python.cpp deleted file mode 100644 index 6f4f2b6f0dac..000000000000 --- a/applications/PFEMapplication/custom_python/add_meshers_to_python.cpp +++ /dev/null @@ -1,79 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.4 $ -// -// - - -// System includes - -// External includes -#include - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "custom_python/add_meshers_to_python.h" - - - -namespace Kratos -{ - -namespace Python -{ - -void AddMeshersToPython() -{ - - using namespace boost::python; -} - -} // namespace Python. - -} // Namespace Kratos - diff --git a/applications/PFEMapplication/custom_python/add_meshers_to_python.h b/applications/PFEMapplication/custom_python/add_meshers_to_python.h deleted file mode 100644 index 9814967af0f1..000000000000 --- a/applications/PFEMapplication/custom_python/add_meshers_to_python.h +++ /dev/null @@ -1,78 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_ADD_MESHERS_TO_PYTHON_H_INCLUDED ) -#define KRATOS_ADD_MESHERS_TO_PYTHON_H_INCLUDED - - - -// System includes - - -// External includes - - -// Project includes -#include "includes/define.h" - - -namespace Kratos -{ - -namespace Python -{ - -void AddMeshersToPython(); - -} // namespace Python. - -} // namespace Kratos. - -#endif // KRATOS_ADD_MESHERS_TO_PYTHON_H_INCLUDED defined diff --git a/applications/PFEMapplication/custom_python/add_processes_to_python.cpp b/applications/PFEMapplication/custom_python/add_processes_to_python.cpp deleted file mode 100644 index 07e860b8d4c6..000000000000 --- a/applications/PFEMapplication/custom_python/add_processes_to_python.cpp +++ /dev/null @@ -1,149 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last modified by: $Author: rrossi $ -// Date: $Date: 2009-01-22 17:13:57 $ -// Revision: $Revision: 1.6 $ -// -// - - -// System includes - -// External includes -#include - - -// Project includes -#include "includes/define.h" -#include "processes/process.h" -#include "custom_python/add_processes_to_python.h" -#include "custom_processes/act_on_walls_nodal_process.h" -#include "custom_processes/find_nodal_h_respecting_distance_process.h" -#include "custom_processes/coordinate_laplacian_smoother_process.h" -#include "custom_processes/move_mesh_process.h" -// #include "custom_processes/node_erase_process.h" -#include "custom_processes/ulf_time_step_dec_process.h" -//#include "custom_processes/lagrangian_inlet_process.h" -#include "includes/node.h" -// #include "custom_processes/create_internal_nodes_process.h" -// #include "custom_processes/particle_to_node_projection_process.h" -// #include "custom_processes/Lagrangian_move_process.h" -// #include "custom_processes/ptn_pressure_projection_process.h" -// #include "custom_processes/ptn_velocity_projection_process.h" -// #include "custom_processes/find_poor_element_process.h" - - - -namespace Kratos -{ - -namespace Python -{ -void AddProcessesToPython() -{ - using namespace boost::python; - -// class_ >("FindNodalHProcess", -// init()) -// ; - - class_ >("ActOnWallsNodalProcess", - init()) - ; - - class_ >("MoveMeshProcess", - init()) - ; - - /* class_ >("LagrangianInletProcess", - init()) - ; - */ - class_ >("CoordinateLaplacianSmootherProcess", - init()) - ; - -// class_ >("NodeEraseProcess", -// init()) -// ; - class_("UlfTimeStepDecProcess", init()) - .def("EstimateDeltaTime",&UlfTimeStepDecProcess::EstimateDeltaTime) - ; - - -// class_ >("CreateInternalNodesProcess", -// init()) -// ; -// -// class_ >("ParticleToNodeProjectionProcess", -// init()) -// ; -// -// // class_ >("MoveParticlesProcess", -// // init()) -// // ; -// -// class_ >("LagrangianMoveProcess", -// init()) -// ; -// -// class_ >("PtNPressureProjectionProcess", -// init()) -// ; -// -// -// class_ >("PtNVelocityProjectionProcess", -// init()) -// ; -// -// class_ >("FindPoorElementProcess", -// init()) -// ; - -} - -} // namespace Python. - -} // Namespace Kratos - diff --git a/applications/PFEMapplication/custom_python/add_processes_to_python.h b/applications/PFEMapplication/custom_python/add_processes_to_python.h deleted file mode 100644 index d818c4460587..000000000000 --- a/applications/PFEMapplication/custom_python/add_processes_to_python.h +++ /dev/null @@ -1,78 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_ADD_PROCESSES_TO_PYTHON_H_INCLUDED ) -#define KRATOS_ADD_PROCESSES_TO_PYTHON_H_INCLUDED - - - -// System includes - - -// External includes - - -// Project includes -#include "includes/define.h" - - -namespace Kratos -{ - -namespace Python -{ - -void AddProcessesToPython(); - -} // namespace Python. - -} // namespace Kratos. - -#endif // KRATOS_ADD_PROCESSES_TO_PYTHON_H_INCLUDED defined diff --git a/applications/PFEMapplication/custom_python/kratos_pfem_python_application.cpp b/applications/PFEMapplication/custom_python/kratos_pfem_python_application.cpp deleted file mode 100644 index a36fb7c3a4c3..000000000000 --- a/applications/PFEMapplication/custom_python/kratos_pfem_python_application.cpp +++ /dev/null @@ -1,108 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last modified by: $Author: rrossi $ -// Date: $Date: 2008-03-05 09:39:14 $ -// Revision: $Revision: 1.6 $ -// -// - -// System includes - -#if defined(KRATOS_PYTHON) -// External includes -#include - - -// Project includes -#include "includes/define.h" -#include "PFEM_application.h" -#include "custom_python/add_meshers_to_python.h" -#include "custom_python/add_custom_utilities_to_python.h" -#include "custom_python/add_processes_to_python.h" -#include "custom_python/add_custom_io_to_python.h" - - -namespace Kratos -{ - -namespace Python -{ - -using namespace boost::python; - - - -BOOST_PYTHON_MODULE(KratosPFEMApplication) -{ - - class_, boost::noncopyable >("KratosPFEMApplication") - ; - AddMeshersToPython(); - AddCustomUtilitiesToPython(); - AddCustomIOToPython(); - AddProcessesToPython(); - - //registering variables in python - /* KRATOS_REGISTER_IN_PYTHON_VARIABLE(NODAL_AREA) - KRATOS_REGISTER_IN_PYTHON_VARIABLE(NODAL_H) - KRATOS_REGISTER_IN_PYTHON_VARIABLE(IS_STRUCTURE) - KRATOS_REGISTER_IN_PYTHON_VARIABLE(IS_FLUID) - KRATOS_REGISTER_IN_PYTHON_VARIABLE(IS_BOUNDARY) - KRATOS_REGISTER_IN_PYTHON_VARIABLE(IS_FREE_SURFACE) - */ -// KRATOS_REGISTER_VARIABLE( PRESSURE_OLD_IT) -// KRATOS_REGISTER_VARIABLE( NODAL_MASS) -// KRATOS_REGISTER_IN_PYTHON_VARIABLE(FRACT_VEL) - KRATOS_REGISTER_IN_PYTHON_VARIABLE(VAUX) - -} - - -} // namespace Python. - -} // namespace Kratos. - -#endif // KRATOS_PYTHON defined diff --git a/applications/PFEMapplication/custom_utilities/binbased_DEM_ULF_coupled_mapping.h b/applications/PFEMapplication/custom_utilities/binbased_DEM_ULF_coupled_mapping.h deleted file mode 100644 index 54ac384029cf..000000000000 --- a/applications/PFEMapplication/custom_utilities/binbased_DEM_ULF_coupled_mapping.h +++ /dev/null @@ -1,844 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: antonia $ -// Date: $Date: 2012-03-08 08:56:42 $ -// -// - -#if !defined(KRATOS_BINBASED_DEM_ULF_COUPLED_MAPPING ) -#define KRATOS_BINBASED_DEM_ULF_COUPLED_MAPPING - -// /* External includes */ -// #include "boost/smart_ptr.hpp" - -// System includes -#include -#include -#include - - -// Project includes -#include "includes/define.h" -#include "includes/model_part.h" -#include "geometries/triangle_2d_3.h" -#include "utilities/timer.h" - -// #include "geometries/tetrahedra_3d_4.h" - -#include "PFEM_application.h" - -//Database includes -#include "spatial_containers/spatial_containers.h" -#include "utilities/binbased_fast_point_locator.h" -#include "utilities/binbased_nodes_in_element_locator.h" - -//iNCLUDE THE DRAG UTILITIED TO CALCULATE THE SEEPAGE DRAG -// #include "custom_utilities/drag_utilities.h" - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// This class allows the interpolation between non-matching meshes in 2D and 3D in the case of the specific application of coupling a -///seepage problem with a granular structural response. -/** @author Antonia Larese De Tetto -* -* For every node of the destination model part it is checked in which element of the origin model part it is -* contained and a linear interpolation is performed -* -* The data structure used by default is a bin, -* -* For a more general tool that allows the mapping between 2 and 3D non-matching meshes, please see /kratos/applications/MeshingApplication/custom_utilities/projection.h -*/ - -//class BinBasedDEMULFCoupledMapping -template -class BinBasedDEMULFCoupledMapping -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of BinBasedDEMULFCoupledMapping - KRATOS_CLASS_POINTER_DEFINITION(BinBasedDEMULFCoupledMapping); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - BinBasedDEMULFCoupledMapping() {} // - - /// Destructor. - virtual ~BinBasedDEMULFCoupledMapping() {} - - - ///@} - ///@name Operators - ///@{ - - - ///@} - ///@name Operations - ///@{ - - - //If you want to pass only one variable - //********************************************************************** - //********************************************************************** - /// Interpolate from the fluid to the DEM mesh - /** - * @param rOrigin_ModelPart: the model part all the variable should be taken from - * @param rDestination_ModelPart: the destination model part where we want to know the values of the variables - * @param bin_of_objects_fluid: precomputed bin of objects (elelments of the fluid mesh). It is to be constructed separately @see binbased_nodes_in_element_locator - - */ - // Form fluid to DEM model part -// template - void InterpolationFromFluidMesh( - ModelPart& rFluid_ModelPart , - ModelPart& rDEM_ModelPart, -// Variable& rOriginVariable , -// Variable& rDestinationVariable, - BinBasedFastPointLocator& bin_of_objects_fluid - ) - { - - KRATOS_TRY - //KRATOS_WATCH("Interpolate From Fluid Mesh*************************************") - //Clear all the variables to be mapped - for (ModelPart::NodesContainerType::iterator node_it = rDEM_ModelPart.NodesBegin(); - node_it != rDEM_ModelPart.NodesEnd(); ++node_it) - { - ClearVariables(node_it, FLUID_VEL_PROJECTED); - ClearVariables(node_it, PRESSURE_GRAD_PROJECTED); - ClearVariables(node_it, FLUID_DENSITY_PROJECTED); - } - - array_1d N; - const int max_results = 10000; - typename BinBasedFastPointLocator::ResultContainerType results(max_results); - const int nparticles = rDEM_ModelPart.Nodes().size(); - int contadorcito = 0; - #pragma omp parallel for firstprivate(results, N) - for (int i = 0; i < nparticles; i++) - { - ModelPart::NodesContainerType::iterator iparticle = rDEM_ModelPart.NodesBegin() + i; - Node < 3 > ::Pointer pparticle = *(iparticle.base()); - - if (pparticle->IsFixed(VELOCITY_X) == false){ - contadorcito++; - typename BinBasedFastPointLocator::ResultIteratorType result_begin = results.begin(); - Element::Pointer pelement; - // look for the fluid element in which the DEM node falls into - bool is_found = bin_of_objects_fluid.FindPointOnMesh(pparticle->Coordinates(), N, pelement, result_begin, max_results); - //interpolate the variables - - if (is_found == true) - { - - //Interpolate( el_it, N, *it_found , rOriginVariable , rDestinationVariable ); - Interpolate( pelement, N, pparticle, DENSITY , FLUID_DENSITY_PROJECTED ); - Interpolate( pelement, N, pparticle, VELOCITY , FLUID_VEL_PROJECTED ); - Interpolate( pelement, N, pparticle, PRESSURE_GRADIENT , PRESSURE_GRAD_PROJECTED ); - - - } - else{ - - } - } - } -// if (contadorcito<8){ -// KRATOS_WATCH("Now it happened!"); -// KRATOS_WATCH(contadorcito); -// KRATOS_THROW_ERROR(std::logic_error,"error",""); -// } -// for (ModelPart::NodesContainerType::iterator node_it = rDEM_ModelPart.NodesBegin(); -// node_it != rDEM_ModelPart.NodesEnd(); ++node_it) -// { -// Node < 3 > ::Pointer pnode = *(node_it.base()); -// double& water_pressure = pnode->FastGetSolutionStepValue(WATER_PRESSURE); -// if (water_pressure < 0.0) -// { -// water_pressure = 0.0; -// } -// } - - - KRATOS_CATCH("") - } - - - - /// Interpolate form the DEM to the fluid mesh - /** - * @param rOrigin_ModelPart: the model part all the variable should be taken from - * @param rDestination_ModelPart: the destination model part where we want to know the values of the variables - * @param bin_of_nodes_fluid: precomputed bin of nodes of the fluid mesh. It is to be constructed separately @see binbased_nodes_in_element_locator - */ - // From DEM to fluid model part -// template - void InterpolationFromDEMMesh( - ModelPart& rDEM_ModelPart , - ModelPart& rFluid_ModelPart, - int n_particles_per_depth_distance, -// Variable& rDEMDomainVariable , -// Variable& rFluidDomainVariable, - BinBasedFastPointLocator& bin_of_objects_fluid //this is a bin of objects which contains the FLUID model part - - ) - { - - KRATOS_TRY - //KRATOS_WATCH("Interpolate From Fluid Mesh*************************************") - //Clear all the variables to be mapped - for (ModelPart::NodesContainerType::iterator node_it = rFluid_ModelPart.NodesBegin(); - node_it != rFluid_ModelPart.NodesEnd(); ++node_it) - { - ClearVariables(node_it, DRAG_REACTION); - } - - - - array_1d N; - const int max_results = 10000; - typename BinBasedFastPointLocator::ResultContainerType results(max_results); - const int nparticles = rDEM_ModelPart.Nodes().size(); - - #pragma omp parallel for firstprivate(results,N) - for (int i = 0; i < nparticles; i++) - { - ModelPart::NodesContainerType::iterator iparticle = rDEM_ModelPart.NodesBegin() + i; - Node < 3 > ::Pointer pparticle = *(iparticle.base()); - typename BinBasedFastPointLocator::ResultIteratorType result_begin = results.begin(); - Element::Pointer pelement; - // look for the fluid element which the DEM node falls into - bool is_found = bin_of_objects_fluid.FindPointOnMesh(pparticle->Coordinates(), N, pelement, result_begin, max_results); - //interpolate the variables - - if (is_found == true) - { - //Interpolate( el_it, N, *it_found , rDestinationVariable , rOriginVariable); - Transfer(pelement, N, pparticle, DRAG_REACTION , DRAG_FORCE, n_particles_per_depth_distance); - } - } - -// for (ModelPart::NodesContainerType::iterator node_it = rDEM_ModelPart.NodesBegin(); -// node_it != rDEM_ModelPart.NodesEnd(); ++node_it) -// { -// Node < 3 > ::Pointer pnode = *(node_it.base()); -// double& water_pressure = pnode->FastGetSolutionStepValue(WATER_PRESSURE); -// if (water_pressure < 0.0) -// { -// water_pressure = 0.0; -// } -// } - - - KRATOS_CATCH("") - } - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a stemplate tring. - virtual std::string Info() const - { - return ""; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const {} - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const {} - - - ///@} - ///@name Friends - ///@{ - - ///@} - -protected: - ///@name Protected static Member rVariables - ///@{ - - - ///@} - ///@name Protected member rVariables - ///@{ template - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member rVariables - ///@{ - - - ///@} - ///@name Member rVariables - ///@{ - - - - inline void CalculateCenterAndSearchRadius(Geometry >&geom, - double& xc, double& yc, double& zc, double& R, array_1d& N - ) - { - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - - - xc = 0.3333333333333333333*(x0+x1+x2); - yc = 0.3333333333333333333*(y0+y1+y2); - zc = 0.0; - - double R1 = (xc-x0)*(xc-x0) + (yc-y0)*(yc-y0); - double R2 = (xc-x1)*(xc-x1) + (yc-y1)*(yc-y1); - double R3 = (xc-x2)*(xc-x2) + (yc-y2)*(yc-y2); - - R = R1; - if (R2 > R) R = R2; - if (R3 > R) R = R3; - - R = 1.01 * sqrt(R); - } - //*************************************** - //*************************************** - inline void CalculateCenterAndSearchRadius(Geometry >&geom, - double& xc, double& yc, double& zc, double& R, array_1d& N - - ) - { - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double z0 = geom[0].Z(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double z1 = geom[1].Z(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - double z2 = geom[2].Z(); - double x3 = geom[3].X(); - double y3 = geom[3].Y(); - double z3 = geom[3].Z(); - - - xc = 0.25*(x0+x1+x2+x3); - yc = 0.25*(y0+y1+y2+y3); - zc = 0.25*(z0+z1+z2+z3); - - double R1 = (xc-x0)*(xc-x0) + (yc-y0)*(yc-y0) + (zc-z0)*(zc-z0); - double R2 = (xc-x1)*(xc-x1) + (yc-y1)*(yc-y1) + (zc-z1)*(zc-z1); - double R3 = (xc-x2)*(xc-x2) + (yc-y2)*(yc-y2) + (zc-z2)*(zc-z2); - double R4 = (xc-x3)*(xc-x3) + (yc-y3)*(yc-y3) + (zc-z3)*(zc-z3); - - R = R1; - if (R2 > R) R = R2; - if (R3 > R) R = R3; - if (R4 > R) R = R4; - - R = sqrt(R); - } - //*************************************** - //*************************************** - inline double CalculateVol( const double x0, const double y0, - const double x1, const double y1, - const double x2, const double y2 - ) - { - return 0.5*( (x1-x0)*(y2-y0)- (y1-y0)*(x2-x0) ); - } - //*************************************** - //*************************************** - inline double CalculateVol( const double x0, const double y0, const double z0, - const double x1, const double y1, const double z1, - const double x2, const double y2, const double z2, - const double x3, const double y3, const double z3 - ) - { - double x10 = x1 - x0; - double y10 = y1 - y0; - double z10 = z1 - z0; - - double x20 = x2 - x0; - double y20 = y2 - y0; - double z20 = z2 - z0; - - double x30 = x3 - x0; - double y30 = y3 - y0; - double z30 = z3 - z0; - - double detJ = x10 * y20 * z30 - x10 * y30 * z20 + y10 * z20 * x30 - y10 * x20 * z30 + z10 * x20 * y30 - z10 * y20 * x30; - return detJ*0.1666666666666666666667; - - //return 0.5*( (x1-x0)*(y2-y0)- (y1-y0)*(x2-x0) ); - } - //*************************************** - //*************************************** - inline bool CalculatePosition( Geometry >&geom, - const double xc, const double yc, const double zc, - array_1d& N - ) - { - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - - double area = CalculateVol(x0,y0,x1,y1,x2,y2); - double inv_area = 0.0; - if (area == 0.0) - { - -// KRATOS_THROW_ERROR(std::logic_error,"element with zero area found",""); - //The interpolated node will not be inside an elemente with zero area - return false; - - } - else - { - inv_area = 1.0 / area; - } - - - N[0] = CalculateVol(x1,y1,x2,y2,xc,yc) * inv_area; - N[1] = CalculateVol(x2,y2,x0,y0,xc,yc) * inv_area; - N[2] = CalculateVol(x0,y0,x1,y1,xc,yc) * inv_area; - - - if (N[0] >= 0.0 && N[1] >= 0.0 && N[2] >= 0.0 && N[0] <=1.0 && N[1]<= 1.0 && N[2] <= 1.0) //if the xc yc is inside the triangle return true - return true; - - return false; - } - - //*************************************** - //*************************************** - - inline bool CalculatePosition( Geometry >&geom, - const double xc, const double yc, const double zc, - array_1d& N - ) - { - - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double z0 = geom[0].Z(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double z1 = geom[1].Z(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - double z2 = geom[2].Z(); - double x3 = geom[3].X(); - double y3 = geom[3].Y(); - double z3 = geom[3].Z(); - - double vol = CalculateVol(x0,y0,z0,x1,y1,z1,x2,y2,z2,x3,y3,z3); - - double inv_vol = 0.0; - if (vol < 0.0000000000001) - { - -// KRATOS_THROW_ERROR(std::logic_error,"element with zero vol found",""); - //The interpolated node will not be inside an elemente with zero volume - return false; -// KRATOS_WATCH("++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++") - } - else - { - inv_vol = 1.0 / vol; - } - - N[0] = CalculateVol(x1,y1,z1,x3,y3,z3,x2,y2,z2,xc,yc,zc) * inv_vol; - N[1] = CalculateVol(x3,y3,z3,x0,y0,z0,x2,y2,z2,xc,yc,zc) * inv_vol; - N[2] = CalculateVol(x3,y3,z3,x1,y1,z1,x0,y0,z0,xc,yc,zc) * inv_vol; - N[3] = CalculateVol(x0,y0,z0,x1,y1,z1,x2,y2,z2,xc,yc,zc) * inv_vol; - - - if (N[0] >= 0.0 && N[1] >= 0.0 && N[2] >= 0.0 && N[3] >=0.0 && - N[0] <= 1.0 && N[1] <= 1.0 && N[2] <= 1.0 && N[3] <=1.0) - //if the xc yc zc is inside the tetrahedron return true - return true; - - return false; - } -//el_it Element iterator -//N Shape functions -//step_data_size -//pnode pointer to the node - - - //projecting an array1D 2Dversion - void Interpolate( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable >& rOriginVariable, - Variable >& rDestinationVariable) - { -// KRATOS_THROW_ERROR(std::logic_error,"INTERPOLATE ARRAY 2D","") - - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - - for (unsigned int step = 0; step < buffer_size; step++) - { - //getting the data of the solution step - array_1d& step_data = (pnode)->FastGetSolutionStepValue(rDestinationVariable , step); - //const array_1d& velocity = (pnode)->FastGetSolutionStepValue(VELOCITY , step); - //Reference or no reference???//CANCELLA - const array_1d& node0_data = geom[0].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node1_data = geom[1].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node2_data = geom[2].FastGetSolutionStepValue(rOriginVariable , step); - - //copying this data in the position of the vector we are interested in - for (unsigned int j= 0; j< TDim; j++) - { - step_data[j] = N[0] * node0_data[j] + N[1] * node1_data[j] + N[2] * node2_data[j]; - - } - - - } -// pnode->GetValue(IS_VISITED) = 1.0; - - } - - //projecting an array1D 3Dversion - void Interpolate( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable >& rOriginVariable, - Variable >& rDestinationVariable) - - { -// KRATOS_THROW_ERROR(std::logic_error,"INTERPOLATE ARRAY 3D","") - - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - - for (unsigned int step = 0; step& step_data = (pnode)->FastGetSolutionStepValue(rDestinationVariable , step); - //Reference or no reference???//CANCELLA - const array_1d& node0_data = geom[0].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node1_data = geom[1].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node2_data = geom[2].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node3_data = geom[3].FastGetSolutionStepValue(rOriginVariable , step); - - //copying this data in the position of the vector we are interested in - for (unsigned int j= 0; j< TDim; j++) - { - step_data[j] = N[0]*node0_data[j] + N[1]*node1_data[j] + N[2]*node2_data[j] + N[3]*node3_data[j]; - } - } -// pnode->GetValue(IS_VISITED) = 1.0; - - } - //projecting a scalar 2Dversion - void Interpolate( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable& rOriginVariable, - Variable& rDestinationVariable) - { -// KRATOS_THROW_ERROR(std::logic_error,"INTERPOLATE SCALAR 2D","") - - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - //facendo un loop sugli step temporali step_data come salva i dati al passo anteriore? CioÅ› dove passiamo l'informazione ai nodi??? - for (unsigned int step = 0; stepFastGetSolutionStepValue(rDestinationVariable , step); - //Reference or no reference???//CANCELLA - const double node0_data = geom[0].FastGetSolutionStepValue(rOriginVariable , step); - const double node1_data = geom[1].FastGetSolutionStepValue(rOriginVariable , step); - const double node2_data = geom[2].FastGetSolutionStepValue(rOriginVariable , step); - - //copying this data in the position of the vector we are interested in - - step_data = N[0] * node0_data + N[1] * node1_data + N[2] * node2_data; - - } -// // pnode->GetValue(IS_VISITED) = 1.0; - - } - //projecting a scalar 3Dversion - void Interpolate( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable& rOriginVariable, - Variable& rDestinationVariable) - { - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - //facendo un loop sugli step temporali step_data come salva i dati al passo anteriore? CioÅ› dove passiamo l'informazione ai nodi??? - for (unsigned int step = 0; stepFastGetSolutionStepValue(rDestinationVariable , step); - //Reference or no reference???//CANCELLA - const double node0_data = geom[0].FastGetSolutionStepValue(rOriginVariable , step); - const double node1_data = geom[1].FastGetSolutionStepValue(rOriginVariable , step); - const double node2_data = geom[2].FastGetSolutionStepValue(rOriginVariable , step); - const double node3_data = geom[3].FastGetSolutionStepValue(rOriginVariable , step); - - //copying this data in the position of the vector we are interested in - - step_data = N[0] * node0_data + N[1] * node1_data + N[2] * node2_data + N[3] * node3_data; -// KRATOS_WATCH(step_data) - } -// pnode->GetValue(IS_VISITED) = 1.0; - - } - //projecting and adding an array1D 2Dversion - void Transfer( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable >& rDestinationVariable, - Variable >& rOriginVariable) - { -// KRATOS_THROW_ERROR(std::logic_error,"INTERPOLATE ARRAY 2D","") - - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - - for (unsigned int step = 0; step& step_data = (pnode)->FastGetSolutionStepValue(rOriginVariable , step); - //Reference or no reference???//CANCELLA - array_1d& node0_data = geom[0].FastGetSolutionStepValue(rDestinationVariable , step); - array_1d& node1_data = geom[1].FastGetSolutionStepValue(rDestinationVariable , step); - array_1d& node2_data = geom[2].FastGetSolutionStepValue(rDestinationVariable , step); - double origin_data; - //copying this data in the position of the vector we are interested in - for (unsigned int j= 0; j< TDim; j++) - { - origin_data = step_data[j]; - node0_data[j] += -N[0] * origin_data; - node1_data[j] += -N[1] * origin_data; - node2_data[j] += -N[2] * origin_data; - } - } -// pnode->GetValue(IS_VISITED) = 1.0; - - } - - //projecting and adding an array1D 3Dversion - void Transfer( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable >& rOriginVariable, - Variable >& rDestinationVariable, - int n_particles_per_depth_distance) - - { -// KRATOS_THROW_ERROR(std::logic_error,"INTERPOLATE ARRAY 3D","") - - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - - for (unsigned int step = 0; step& step_data = (pnode)->FastGetSolutionStepValue(rDestinationVariable , step); - const array_1d& node0_data = geom[0].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node1_data = geom[1].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node2_data = geom[2].FastGetSolutionStepValue(rOriginVariable , step); - //const array_1d& node3_data = geom[3].FastGetSolutionStepValue(rOriginVariable , step); - //copying this data in the position of the vector we are interested in - for (unsigned int j= 0; j< TDim; j++) - { - step_data[j] = n_particles_per_depth_distance * (N[0] * node0_data[j] + N[1] * node1_data[j] + N[2] * node2_data[j]); - } - } -// pnode->GetValue(IS_VISITED) = 1.0; - - } - inline void Clear(ModelPart::NodesContainerType::iterator node_it, int step_data_size ) - { - unsigned int buffer_size = node_it->GetBufferSize(); - - for (unsigned int step = 0; stepSolutionStepData().Data(step); - - //copying this data in the position of the vector we are interested in - for (int j= 0; j< step_data_size; j++) - { - step_data[j] = 0.0; - } - } - - } - - inline void ClearVariables(ModelPart::NodesContainerType::iterator node_it , Variable >& rVariable) - { - array_1d& Aux_var = node_it->FastGetSolutionStepValue(rVariable, 0); - - noalias(Aux_var) = ZeroVector(3); - - } - - - inline void ClearVariables(ModelPart::NodesContainerType::iterator node_it, Variable& rVariable) - { - double& Aux_var = node_it->FastGetSolutionStepValue(rVariable, 0); - - Aux_var = 0.0; - - } - - - - - ///@} - ///@name Private Operators - ///@{ - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - BinBasedDEMULFCoupledMapping& operator=(BinBasedDEMULFCoupledMapping const& rOther); - - - ///@} - -}; // Class BinBasedDEMULFCoupledMapping - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - - - -/// output stream function -template -inline std::ostream& operator << (std::ostream& rOStream, - const BinBasedDEMULFCoupledMapping& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_BINBASED_DEM_ULF_COUPLED_MAPPING defined - - diff --git a/applications/PFEMapplication/custom_utilities/binbased_seepage_coupled_mapping.h b/applications/PFEMapplication/custom_utilities/binbased_seepage_coupled_mapping.h deleted file mode 100644 index 9610a9b7f959..000000000000 --- a/applications/PFEMapplication/custom_utilities/binbased_seepage_coupled_mapping.h +++ /dev/null @@ -1,776 +0,0 @@ -// -// Project Name: Kratos -// Last Modified by: $Author: antonia $ -// Date: $Date: 2012-03-08 08:56:42 $ -// -// - -#if !defined(KRATOS_BINBASED_SEEPAGE_COUPLED_MAPPING ) -#define KRATOS_BINBASED_SEEPAGE_COUPLED_MAPPING - -// /* External includes */ -// #include "boost/smart_ptr.hpp" - -// System includes -#include -#include -#include - - -// Project includes -#include "includes/define.h" -#include "includes/model_part.h" -#include "geometries/triangle_2d_3.h" -#include "utilities/timer.h" - -// #include "geometries/tetrahedra_3d_4.h" - -#include "PFEM_application.h" - -//Database includes -#include "spatial_containers/spatial_containers.h" -#include "utilities/binbased_fast_point_locator.h" -#include "utilities/binbased_nodes_in_element_locator.h" - -//iNCLUDE THE DRAG UTILITIED TO CALCULATE THE SEEPAGE DRAG -// #include "custom_utilities/drag_utilities.h" - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// This class allows the interpolation between non-matching meshes in 2D and 3D in the case of the specific application of coupling a -///seepage problem with a granular structural response. -/** @author Antonia Larese De Tetto -* -* For every node of the destination model part it is checked in which element of the origin model part it is -* contained and a linear interpolation is performed -* -* The data structure used by default is a bin, -* -* For a more general tool that allows the mapping between 2 and 3D non-matching meshes, please see /kratos/applications/MeshingApplication/custom_utilities/projection.h -*/ - -//class BinBasedSeepageCoupledMapping -template -class BinBasedSeepageCoupledMapping -{ -public: - ///@name Type Definitions - ///@{ - - /// Pointer definition of BinBasedSeepageCoupledMapping - KRATOS_CLASS_POINTER_DEFINITION(BinBasedSeepageCoupledMapping); - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - BinBasedSeepageCoupledMapping() {} // - - /// Destructor. - virtual ~BinBasedSeepageCoupledMapping() {} - - - ///@} - ///@name Operators - ///@{ - - - ///@} - ///@name Operations - ///@{ - - - //If you want to pass only one variable - //********************************************************************** - //********************************************************************** - /// Interpolate from the fixed to the moving mesh - /** - * @param rOrigin_ModelPart: the model part all the variable should be taken from - * @param rDestination_ModelPart: the destination model part where we want to know the values of the variables - * @param bin_of_objects_fixed: precomputed bin of objects (elelments of the fixed mesh). It is to be constructed separately @see binbased_nodes_in_element_locator - - */ - // Form fixed to moving model part -// template - void InterpolationFromFixedMesh( - ModelPart& rFixed_ModelPart , - ModelPart& rMoving_ModelPart, -// Variable& rOriginVariable , -// Variable& rDestinationVariable, - BinBasedFastPointLocator& bin_of_objects_fixed - ) - { - - KRATOS_TRY - KRATOS_WATCH("Interpolate From Fixed Mesh*************************************") - //Clear all the variables to be mapped - for(ModelPart::NodesContainerType::iterator node_it = rMoving_ModelPart.NodesBegin(); - node_it != rMoving_ModelPart.NodesEnd(); ++node_it) - { - - ClearVariables(node_it, WATER_PRESSURE); - ClearVariables(node_it, SEEPAGE_DRAG); - ClearVariables(node_it, PRESS_PROJ); - } - - - - array_1d N; - const int max_results = 10000; - typename BinBasedFastPointLocator::ResultContainerType results(max_results); - const int nparticles = rMoving_ModelPart.Nodes().size(); - - #pragma omp parallel for firstprivate(results,N) - for (int i = 0; i < nparticles; i++) - { - ModelPart::NodesContainerType::iterator iparticle = rMoving_ModelPart.NodesBegin() + i; - Node < 3 > ::Pointer pparticle = *(iparticle.base()); - typename BinBasedFastPointLocator::ResultIteratorType result_begin = results.begin(); - Element::Pointer pelement; - // look for the fixed element in which the moving node falls into - bool is_found = bin_of_objects_fixed.FindPointOnMesh(pparticle->Coordinates(), N, pelement, result_begin, max_results); - //interpolate the variables - - if (is_found == true) - { - //Interpolate( el_it, N, *it_found , rOriginVariable , rDestinationVariable ); - Interpolate( pelement, N, pparticle, PRESSURE , WATER_PRESSURE ); - Interpolate( pelement, N, pparticle, SEEPAGE_DRAG , SEEPAGE_DRAG ); - Interpolate( pelement, N, pparticle, PRESS_PROJ , PRESS_PROJ ); - } - } - - for(ModelPart::NodesContainerType::iterator node_it = rMoving_ModelPart.NodesBegin(); - node_it != rMoving_ModelPart.NodesEnd(); ++node_it) - { - Node < 3 > ::Pointer pnode = *(node_it.base()); - double& water_pressure = pnode->FastGetSolutionStepValue(WATER_PRESSURE); - if(water_pressure < 0.0) - { - water_pressure = 0.0; - } - } - - - KRATOS_CATCH("") - } - - - - /// Interpolate form the moving to the fixed mesh - /** - * @param rOrigin_ModelPart: the model part all the variable should be taken from - * @param rDestination_ModelPart: the destination model part where we want to know the values of the variables - * @param bin_of_nodes_fixed: precomputed bin of nodes of the fixed mesh. It is to be constructed separately @see binbased_nodes_in_element_locator - */ - // From moving to fixed model part -// template - void InterpolationFromMovingMesh( - ModelPart& rMoving_ModelPart , - ModelPart& rFixed_ModelPart, -// Variable& rMovingDomainVariable , -// Variable& rFixedDomainVariable, - BinBasedNodesInElementLocator& bin_of_nodes_fixed //this is a bin of objects which contains the FIXED model part - - ) - { - KRATOS_TRY - -// KRATOS_WATCH("Transfer From Moving Mesh*************************************") -// if (rMoving_ModelPart.NodesBegin()->SolutionStepsDataHas(rMovingDomainVariable) == false) -// KRATOS_THROW_ERROR(std::logic_error, "Add MovingDomain VARIABLE!!!!!! ERROR", ""); -// if (rFixed_ModelPart.NodesBegin()->SolutionStepsDataHas(rFixedDomainVariable) == false) -// KRATOS_THROW_ERROR(std::logic_error, "Add FixedDomain VARIABLE!!!!!! ERROR", ""); - - - //clearing all the mapped variables - for(ModelPart::NodesContainerType::iterator node_it = rFixed_ModelPart.NodesBegin(); - node_it != rFixed_ModelPart.NodesEnd(); ++node_it) - { - ClearVariables(node_it, POROSITY); - ClearVariables(node_it, DIAMETER); - ClearVariables(node_it, STRUCTURE_VELOCITY); - } - - //defintions for spatial search -// typedef typename BinBasedNodesInElementLocator::PointType PointType; - //typedef typename PointType::Pointer PointTypePointer; - typedef typename BinBasedNodesInElementLocator::PointIterator PointIterator; - //typedef typename BinBasedNodesInElementLocator::DistanceIterator DistanceIterator; - typedef typename BinBasedNodesInElementLocator::PointVector PointVector; - typedef typename BinBasedNodesInElementLocator::DistanceVector DistanceVector; - - const unsigned int max_results = 10000; - Matrix Nmat(max_results,TDim+1); - boost::numeric::ublas::vector positions(max_results); - PointVector work_results(max_results); - DistanceVector work_distances(max_results); - Node<3> work_point(0,0.0,0.0,0.0); - - for(ModelPart::ElementsContainerType::iterator elem_it = rMoving_ModelPart.ElementsBegin(); elem_it != rMoving_ModelPart.ElementsEnd(); ++elem_it) - { - - //look for all the fixed nodes in a moving element - unsigned int nfound = bin_of_nodes_fixed.FindNodesInElement(*(elem_it.base()), positions, Nmat, max_results, work_results.begin(), work_distances.begin(), work_point); - for(unsigned int k=0; k N = row(Nmat,k); - - Interpolate( *(elem_it.base()), N, *it, POROSITY , POROSITY); - Interpolate( *(elem_it.base()), N, *it, DIAMETER , DIAMETER); - Interpolate( *(elem_it.base()), N, *it, VELOCITY , STRUCTURE_VELOCITY); - } - - } - - for(ModelPart::NodesContainerType::iterator node_it = rFixed_ModelPart.NodesBegin(); - node_it != rFixed_ModelPart.NodesEnd(); ++node_it) - { - Node < 3 > ::Pointer pnode = *(node_it.base()); - double& porosity = pnode->FastGetSolutionStepValue(POROSITY); - double& diameter = pnode->FastGetSolutionStepValue(DIAMETER); - if(porosity == 0.0) - { - porosity = 1.0; - } - if(diameter == 0.0) - { - diameter = 1.0; - } - } - - KRATOS_CATCH("") - } - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a stemplate tring. - virtual std::string Info() const - { - return ""; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const {} - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const {} - - - ///@} - ///@name Friends - ///@{ - - ///@} - -protected: - ///@name Protected static Member rVariables - ///@{ - - - ///@} - ///@name Protected member rVariables - ///@{ template - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member rVariables - ///@{ - - - ///@} - ///@name Member rVariables - ///@{ - - - - inline void CalculateCenterAndSearchRadius(Geometry >&geom, - double& xc, double& yc, double& zc, double& R, array_1d& N - ) - { - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - - - xc = 0.3333333333333333333*(x0+x1+x2); - yc = 0.3333333333333333333*(y0+y1+y2); - zc = 0.0; - - double R1 = (xc-x0)*(xc-x0) + (yc-y0)*(yc-y0); - double R2 = (xc-x1)*(xc-x1) + (yc-y1)*(yc-y1); - double R3 = (xc-x2)*(xc-x2) + (yc-y2)*(yc-y2); - - R = R1; - if(R2 > R) R = R2; - if(R3 > R) R = R3; - - R = 1.01 * sqrt(R); - } - //*************************************** - //*************************************** - inline void CalculateCenterAndSearchRadius(Geometry >&geom, - double& xc, double& yc, double& zc, double& R, array_1d& N - - ) - { - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double z0 = geom[0].Z(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double z1 = geom[1].Z(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - double z2 = geom[2].Z(); - double x3 = geom[3].X(); - double y3 = geom[3].Y(); - double z3 = geom[3].Z(); - - - xc = 0.25*(x0+x1+x2+x3); - yc = 0.25*(y0+y1+y2+y3); - zc = 0.25*(z0+z1+z2+z3); - - double R1 = (xc-x0)*(xc-x0) + (yc-y0)*(yc-y0) + (zc-z0)*(zc-z0); - double R2 = (xc-x1)*(xc-x1) + (yc-y1)*(yc-y1) + (zc-z1)*(zc-z1); - double R3 = (xc-x2)*(xc-x2) + (yc-y2)*(yc-y2) + (zc-z2)*(zc-z2); - double R4 = (xc-x3)*(xc-x3) + (yc-y3)*(yc-y3) + (zc-z3)*(zc-z3); - - R = R1; - if(R2 > R) R = R2; - if(R3 > R) R = R3; - if(R4 > R) R = R4; - - R = sqrt(R); - } - //*************************************** - //*************************************** - inline double CalculateVol( const double x0, const double y0, - const double x1, const double y1, - const double x2, const double y2 - ) - { - return 0.5*( (x1-x0)*(y2-y0)- (y1-y0)*(x2-x0) ); - } - //*************************************** - //*************************************** - inline double CalculateVol( const double x0, const double y0, const double z0, - const double x1, const double y1, const double z1, - const double x2, const double y2, const double z2, - const double x3, const double y3, const double z3 - ) - { - double x10 = x1 - x0; - double y10 = y1 - y0; - double z10 = z1 - z0; - - double x20 = x2 - x0; - double y20 = y2 - y0; - double z20 = z2 - z0; - - double x30 = x3 - x0; - double y30 = y3 - y0; - double z30 = z3 - z0; - - double detJ = x10 * y20 * z30 - x10 * y30 * z20 + y10 * z20 * x30 - y10 * x20 * z30 + z10 * x20 * y30 - z10 * y20 * x30; - return detJ*0.1666666666666666666667; - - //return 0.5*( (x1-x0)*(y2-y0)- (y1-y0)*(x2-x0) ); - } - //*************************************** - //*************************************** - inline bool CalculatePosition( Geometry >&geom, - const double xc, const double yc, const double zc, - array_1d& N - ) - { - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - - double area = CalculateVol(x0,y0,x1,y1,x2,y2); - double inv_area = 0.0; - if(area == 0.0) - { - -// KRATOS_THROW_ERROR(std::logic_error,"element with zero area found",""); - //The interpolated node will not be inside an elemente with zero area - return false; - - } - else - { - inv_area = 1.0 / area; - } - - - N[0] = CalculateVol(x1,y1,x2,y2,xc,yc) * inv_area; - N[1] = CalculateVol(x2,y2,x0,y0,xc,yc) * inv_area; - N[2] = CalculateVol(x0,y0,x1,y1,xc,yc) * inv_area; - - - if(N[0] >= 0.0 && N[1] >= 0.0 && N[2] >= 0.0 && N[0] <=1.0 && N[1]<= 1.0 && N[2] <= 1.0) //if the xc yc is inside the triangle return true - return true; - - return false; - } - - //*************************************** - //*************************************** - - inline bool CalculatePosition( Geometry >&geom, - const double xc, const double yc, const double zc, - array_1d& N - ) - { - - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double z0 = geom[0].Z(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double z1 = geom[1].Z(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - double z2 = geom[2].Z(); - double x3 = geom[3].X(); - double y3 = geom[3].Y(); - double z3 = geom[3].Z(); - - double vol = CalculateVol(x0,y0,z0,x1,y1,z1,x2,y2,z2,x3,y3,z3); - - double inv_vol = 0.0; - if(vol < 0.0000000000001) - { - -// KRATOS_THROW_ERROR(std::logic_error,"element with zero vol found",""); - //The interpolated node will not be inside an elemente with zero volume - return false; -// KRATOS_WATCH("++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++") - } - else - { - inv_vol = 1.0 / vol; - } - - N[0] = CalculateVol(x1,y1,z1,x3,y3,z3,x2,y2,z2,xc,yc,zc) * inv_vol; - N[1] = CalculateVol(x3,y3,z3,x0,y0,z0,x2,y2,z2,xc,yc,zc) * inv_vol; - N[2] = CalculateVol(x3,y3,z3,x1,y1,z1,x0,y0,z0,xc,yc,zc) * inv_vol; - N[3] = CalculateVol(x0,y0,z0,x1,y1,z1,x2,y2,z2,xc,yc,zc) * inv_vol; - - - if(N[0] >= 0.0 && N[1] >= 0.0 && N[2] >= 0.0 && N[3] >=0.0 && - N[0] <= 1.0 && N[1] <= 1.0 && N[2] <= 1.0 && N[3] <=1.0) - //if the xc yc zc is inside the tetrahedron return true - return true; - - return false; - } -//el_it Element iterator -//N Shape functions -//step_data_size -//pnode pointer to the node - - - //projecting an array1D 2Dversion - void Interpolate( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable >& rOriginVariable, - Variable >& rDestinationVariable) - { -// KRATOS_THROW_ERROR(std::logic_error,"INTERPOLATE ARRAY 2D","") - - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - - for(unsigned int step = 0; step& step_data = (pnode)->FastGetSolutionStepValue(rDestinationVariable , step); - //Reference or no reference???//CANCELLA - const array_1d& node0_data = geom[0].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node1_data = geom[1].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node2_data = geom[2].FastGetSolutionStepValue(rOriginVariable , step); - - //copying this data in the position of the vector we are interested in - for(unsigned int j= 0; j< TDim; j++) - { - step_data[j] = N[0]*node0_data[j] + N[1]*node1_data[j] + N[2]*node2_data[j]; - } - } -// pnode->GetValue(IS_VISITED) = 1.0; - - } - - //projecting an array1D 3Dversion - void Interpolate( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable >& rOriginVariable, - Variable >& rDestinationVariable) - - { -// KRATOS_THROW_ERROR(std::logic_error,"INTERPOLATE ARRAY 3D","") - - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - - for(unsigned int step = 0; step& step_data = (pnode)->FastGetSolutionStepValue(rDestinationVariable , step); - //Reference or no reference???//CANCELLA - const array_1d& node0_data = geom[0].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node1_data = geom[1].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node2_data = geom[2].FastGetSolutionStepValue(rOriginVariable , step); - const array_1d& node3_data = geom[3].FastGetSolutionStepValue(rOriginVariable , step); - - //copying this data in the position of the vector we are interested in - for(unsigned int j= 0; j< TDim; j++) - { - step_data[j] = N[0]*node0_data[j] + N[1]*node1_data[j] + N[2]*node2_data[j] + N[3]*node3_data[j]; - } - } -// pnode->GetValue(IS_VISITED) = 1.0; - - } - //projecting a scalar 2Dversion - void Interpolate( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable& rOriginVariable, - Variable& rDestinationVariable) - { -// KRATOS_THROW_ERROR(std::logic_error,"INTERPOLATE SCALAR 2D","") - - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - //facendo un loop sugli step temporali step_data come salva i dati al passo anteriore? CioÅ› dove passiamo l'informazione ai nodi??? - for(unsigned int step = 0; stepFastGetSolutionStepValue(rDestinationVariable , step); - //Reference or no reference???//CANCELLA - const double node0_data = geom[0].FastGetSolutionStepValue(rOriginVariable , step); - const double node1_data = geom[1].FastGetSolutionStepValue(rOriginVariable , step); - const double node2_data = geom[2].FastGetSolutionStepValue(rOriginVariable , step); - - //copying this data in the position of the vector we are interested in - - step_data = N[0]*node0_data + N[1]*node1_data + N[2]*node2_data; - - } -// // pnode->GetValue(IS_VISITED) = 1.0; - - } - //projecting a scalar 3Dversion - void Interpolate( - Element::Pointer el_it, - const array_1d& N, - Node<3>::Pointer pnode, - Variable& rOriginVariable, - Variable& rDestinationVariable) - { - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - - unsigned int buffer_size = pnode->GetBufferSize(); - //facendo un loop sugli step temporali step_data come salva i dati al passo anteriore? CioÅ› dove passiamo l'informazione ai nodi??? - for(unsigned int step = 0; stepFastGetSolutionStepValue(rDestinationVariable , step); - //Reference or no reference???//CANCELLA - const double node0_data = geom[0].FastGetSolutionStepValue(rOriginVariable , step); - const double node1_data = geom[1].FastGetSolutionStepValue(rOriginVariable , step); - const double node2_data = geom[2].FastGetSolutionStepValue(rOriginVariable , step); - const double node3_data = geom[3].FastGetSolutionStepValue(rOriginVariable , step); - - //copying this data in the position of the vector we are interested in - - step_data = N[0]*node0_data + N[1]*node1_data + N[2]*node2_data + N[3]*node3_data; -// KRATOS_WATCH(step_data) - } -// pnode->GetValue(IS_VISITED) = 1.0; - - } - inline void Clear(ModelPart::NodesContainerType::iterator node_it, int step_data_size ) - { - unsigned int buffer_size = node_it->GetBufferSize(); - - for(unsigned int step = 0; stepSolutionStepData().Data(step); - - //copying this data in the position of the vector we are interested in - for(int j= 0; j< step_data_size; j++) - { - step_data[j] = 0.0; - } - } - - } - - inline void ClearVariables(ModelPart::NodesContainerType::iterator node_it , Variable >& rVariable) - { - array_1d& Aux_var = node_it->FastGetSolutionStepValue(rVariable, 0); - - noalias(Aux_var) = ZeroVector(3); - - } - - - inline void ClearVariables(ModelPart::NodesContainerType::iterator node_it, Variable& rVariable) - { - double& Aux_var = node_it->FastGetSolutionStepValue(rVariable, 0); - - Aux_var = 0.0; - - } - - - - - ///@} - ///@name Private Operators - ///@{ - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - BinBasedSeepageCoupledMapping& operator=(BinBasedSeepageCoupledMapping const& rOther); - - - ///@} - -}; // Class BinBasedSeepageCoupledMapping - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - - - -/// output stream function -template -inline std::ostream& operator << (std::ostream& rOStream, - const BinBasedSeepageCoupledMapping& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_BINBASED_SEEPAGE_COUPLED_MAPPING defined - - diff --git a/applications/PFEMapplication/custom_utilities/drag_utilities.h b/applications/PFEMapplication/custom_utilities/drag_utilities.h deleted file mode 100644 index a7ed77a8948d..000000000000 --- a/applications/PFEMapplication/custom_utilities/drag_utilities.h +++ /dev/null @@ -1,330 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - - -/* ********************************************************* -* -* Last Modified by: $Author: antonia $ -* Date: $Date: 2009-10-19 12:12:16 $ -* Revision: $Revision: 0.1 $ -* -* ***********************************************************/ - -#if !defined(KRATOS_DRAG_UTILS ) -#define KRATOS_DRAG_UTILS - - -/* System includes */ -#include -#include -#include - -/* External includes */ - - -/* Project includes */ -#include "utilities/math_utils.h" -#include "includes/model_part.h" -#include "includes/define.h" -#include "includes/node.h" -// #include "includes/element.h" -#include "includes/cfd_variables.h" - -#include "PFEM_application.h" - - -//Database includes -// #include "spatial_containers/spatial_containers.h" - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - - -///@} -///@name Type Definitions -///@{ - - -///@} - - -///@name Enum's */ -///@{ - - -///@} -///@name Functions */ -///@{ - - -///@} -///@name Kratos Classes */ -///@{ - -/// This class allows the calculation of the seepage drag that the fluid transmits to the solid porous matrix. -/** @author Antonia Larese De Tetto -* -* This class includes some usefull utilities for the calculation of the drag that water -* makes on the solid porous matrix in a coupled problem. -* This utilities are used in the pfem_nonnewtonian_coupled gid problem type -* where an edgebased model is used for the calculation of evolution of the fluid @see edgebased_levelset.h -* and it is coupled with a pfem non newtonian visco rigid model is used to avaluate the structural response @see nonewtonian_asgs_2d.h, nonewtonian_asgs_3d.h -*/ - -class DragUtils -{ -public: - ///@name Type Definitions - ///@{ - typedef ModelPart::NodesContainerType NodesArrayType; - typedef ModelPart::ElementsContainerType ElementsArrayType; - ///@} - /**@name Life Cycle - */ - /*@{ */ - - /** Constructor. - */ - - - /** Destructor. - */ - - /*@} */ - /**@name Operators - */ - /*@{ */ - - - /*@} */ - /**@name Operations */ - /*@{ */ - - - - /// Provides the global indices for each one of this element's local rows - /** - * Seepage drag is evaluated in the fluid edgebased model part. Ready to be projected to the structural pfem mesh. - * - * @param rFluid_ModelPart: The fluid model part where Seepage drag has been evaluated for the current time step @see nonewtonian_asgs_2d.h, nonewtonian_asgs_3d.h - * @param rSeepageDragVar: The seepage drag vector that is evaluated in the fluid model part - * @param mu: Fluid viscosity - * @param fluid_density: Fluid density - * @param solid_density: Solid density - - */ - void CalculateFluidDrag( - ModelPart& rFluid_ModelPart, - Variable< array_1d >& rSeepageDragVar, - const double & fluid_nu , - const double & fluid_density, - const double & solid_density - ) - { - - KRATOS_TRY - - for ( ModelPart::NodesContainerType::iterator inode = rFluid_ModelPart.NodesBegin(); - inode != rFluid_ModelPart.NodesEnd(); - inode++) - { - if (inode->FastGetSolutionStepValue(DISTANCE) < 0.0) - { - const double& porosity = inode->FastGetSolutionStepValue(POROSITY); - const double& diameter = inode->FastGetSolutionStepValue(DIAMETER); - //Nodal velocity - const array_1d& fluid_vel = inode->FastGetSolutionStepValue(VELOCITY); - const array_1d& structure_vel = inode->FastGetSolutionStepValue(STRUCTURE_VELOCITY); - - double fluid_vel_norm = norm_2(fluid_vel); - double structure_vel_norm = norm_2(structure_vel); - array_1d str_fl_vel= ZeroVector(3); - for (unsigned int k= 0; k < 3; k++) - { - str_fl_vel[k] = fluid_vel[k] * structure_vel[k]; - } - - array_1d& darcy_term = inode->FastGetSolutionStepValue(rSeepageDragVar); -// KRATOS_WATCH(inode->Id()) -// KRATOS_WATCH(vel) -// KRATOS_WATCH(vel_norm) - - //dimensionally accelerations. A, B not multiplied by porosity like in the fluid momentum equation - double lin_coeff = 150 * fluid_nu * (1-porosity)*(1-porosity)/(porosity*porosity*porosity*diameter*diameter); - double non_lin_coeff = 1.75 * (1-porosity)/(porosity*porosity*porosity*diameter); - //DarcyTerm = LinC * (uf-us) + NonLinC * (uf-us)^2 -----> LinC * uf + NonLinC * uf^2 - LinC * us - NonLinC * us^2 - 2 * NonLinC * uf * us. - noalias(darcy_term) = (lin_coeff + non_lin_coeff * fluid_vel_norm) * fluid_vel * fluid_density / solid_density; - // subtracting the effect of structural velocity. -Aus + Bus^2 - 2B us uf - darcy_term += (((-lin_coeff + non_lin_coeff * structure_vel_norm) * structure_vel - 2 * non_lin_coeff * str_fl_vel)) * fluid_density / solid_density; - - } - } - - KRATOS_CATCH("") - - } - - /// Adds the drag to the body force vector of the structural model - /** - * After projecting the seepage drag on the structural pfem mesh - * body force vector of the structural model part is constructed with the gravity and the seepage_drag contributions - * - * @param rStructural_ModelPart: The structural model part - * @param rSeepageDragVar: the seepage drag nodal vector - * @param rBodyForce: the body force vector that will be reset and calculated as the sum of the gravity contribution and the seepage drag contribution - * @param rGravityAcc: the gravity acceleration vector - */ - void AddDrag( - ModelPart& rStructural_ModelPart, - const Variable< array_1d >& rSeepageDragVar, - Variable< array_1d >& rBodyForce, - const array_1d& rGravityAcc - ) - { - - KRATOS_TRY - for ( ModelPart::NodesContainerType::iterator inode = rStructural_ModelPart.NodesBegin(); - inode != rStructural_ModelPart.NodesEnd(); - inode++) - { -// if(inode->FastGetSolutionStepValue(IS_STRUCTURE) == 0) -// { - const double& porosity = inode->FastGetSolutionStepValue(POROSITY); - const array_1d& press_grad = inode->FastGetSolutionStepValue(PRESS_PROJ); - const double& solid_density = inode->FastGetSolutionStepValue(DENSITY); - - array_1d& bodyforce_drag = inode->FastGetSolutionStepValue(rBodyForce); - bodyforce_drag = inode->FastGetSolutionStepValue(rSeepageDragVar); - - ////subtracting buoyancy force - if (inode->FastGetSolutionStepValue(WATER_PRESSURE) > 0.0) //TO IDENTIFY FLUID NODES...we don't have any information over distance - { - noalias(bodyforce_drag) -= (1-porosity) * press_grad / solid_density; -// array_1d temp = (1-porosity) * press_grad / solid_density; -// KRATOS_WATCH(porosity); -// KRATOS_WATCH(press_grad); -// KRATOS_WATCH(solid_density); - } - - bodyforce_drag += rGravityAcc; -// KRATOS_WATCH(bodyforce_drag) -// } - } - - KRATOS_CATCH("") - - } - - - - - - /*@} */ - /**@name Acces */ - /*@{ */ - - - /*@} */ - /**@name Inquiry */ - /*@{ */ - - - /*@} */ - /**@name Friends */ - /*@{ */ - - - /*@} */ - -private: - ///@name Static Member rVariables - ///@{ - - - ///@} - ///@name Member rVariables - ///@{ - - - ///@} - ///@name Private Operators*/ - ///@{ - - - ///@} - ///@name Private Operations*/ - ///@{ - - - ///@} - ///@name Private Acces */ - ///@{ - - - ///@} - ///@name Private Inquiry */ - ///@{ - - - ///@} - ///@name Un accessible methods */ - ///@{ - - - ///@} - -}; /* Class ClassName */ - -///@} - -/**@name Type Definitions */ -///@{ - - -///@} - -} /* namespace Kratos.*/ - -#endif /* KRATOS_DRAG_UTILS defined */ - diff --git a/applications/PFEMapplication/custom_utilities/erosion_utilities.h b/applications/PFEMapplication/custom_utilities/erosion_utilities.h deleted file mode 100644 index c0a7a6ff62fd..000000000000 --- a/applications/PFEMapplication/custom_utilities/erosion_utilities.h +++ /dev/null @@ -1,917 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - - -/* ********************************************************* -* -* Last Modified by: $Author: antonia $ -* Date: $Date: 2009-10-19 12:12:16 $ -* Revision: $Revision: 0.1 $ -* -* ***********************************************************/ - -#if !defined(KRATOS_EROSION_UTILS ) -#define KRATOS_EROSION_UTILS - - -/* System includes */ -#include -#include -#include -#include - -/* External includes */ - - -/* Project includes */ -#include "utilities/math_utils.h" -#include "includes/model_part.h" -#include "includes/define.h" -// #include "utilities/projection.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/deprecated_variables.h" -#include "PFEM_application.h" -#include "includes/deprecated_variables.h" - -//Database includes -#include "spatial_containers/spatial_containers.h" - -namespace Kratos -{ - -/**@name Kratos Globals */ -/*@{ */ - - -/*@} */ -/**@name Type Definitions */ -/*@{ */ - - -/*@} */ - - -/**@name Enum's */ -/*@{ */ - - -/*@} */ -/**@name Functions */ -/*@{ */ - - - -/*@} */ -/**@name Kratos Classes */ -/*@{ */ - -/** Short class definition. -Detail class definition. - - \URL[Example of use html]{ extended_documentation/no_ex_of_use.html} - - \URL[Example of use pdf]{ extended_documentation/no_ex_of_use.pdf} - - \URL[Example of use doc]{ extended_documentation/no_ex_of_use.doc} - - \URL[Example of use ps]{ extended_documentation/no_ex_of_use.ps} - - - \URL[Extended documentation html]{ extended_documentation/no_ext_doc.html} - - \URL[Extended documentation pdf]{ extended_documentation/no_ext_doc.pdf} - - \URL[Extended documentation doc]{ extended_documentation/no_ext_doc.doc} - - \URL[Extended documentation ps]{ extended_documentation/no_ext_doc.ps} - - -*/ -template< std::size_t TDim> -class ErosionUtils -{ -public: - /**@name Type Definitions */ - /*@{ */ - typedef ModelPart::NodesContainerType NodesArrayType; - typedef ModelPart::ElementsContainerType ElementsArrayType; - /*@} */ - /**@name Life Cycle - */ - /*@{ */ - - /** Constructor. - */ - - - /** Destructor. - */ - - /*@} */ - /**@name Operators - */ - /*@{ */ - - - /*@} */ - /**@name Operations */ - /*@{ */ - - bool CheckErosionableNodes( - ModelPart& rOrigin_ModelPart , - ModelPart& rDestination_ModelPart, - const Vector& rCriticalVel, //TO BE INSERTED - const double rCriticalEnergy, - const double fluid_nu, - const double fluid_rho - ) - { - - KRATOS_TRY -// KRATOS_WATCH( "Line 170") -// //properties to be used in the generation -// Properties::Pointer properties = rDestination_ModelPart.GetMesh().pGetProperties(1); -// -// //defintions for spatial search - typedef Node<3> PointType; - typedef Node<3>::Pointer PointTypePointer; - typedef std::vector PointVector; - typedef std::vector::iterator PointIterator; - typedef std::vector DistanceVector; - typedef std::vector::iterator DistanceIterator; - - //************* - // Bucket types - typedef Bucket< TDim, PointType, PointVector, PointTypePointer, PointIterator, DistanceIterator > BucketType; -// typedef Bins< TDim, PointType, PointVector, PointTypePointer, PointIterator, DistanceIterator > StaticBins; -// typedef BinsDynamic< TDim, PointType, PointVector, PointTypePointer, PointIterator, DistanceIterator > DynamicBins; - //************* - // DynamicBins; - - typedef Tree< KDTreePartition > tree; //Kdtree; -// typedef Tree< OCTreePartition > tree; //Octree; -// typedef Tree< StaticBins > tree; //Binstree; -// typedef Tree< KDTreePartition > tree; //KdtreeBins; -// typedef typename KdtreeBins::Partitions SubPartitions; -// typedef Tree< OCTreePartition > tree; //OctreeBins; - /* - typedef Bins< TDim, PointType, stdPointVector> stdBins; - typedef Tree< Bins > tree; //stdStaticBins;*/ -// KRATOS_WATCH( "Line 199") - - for(ModelPart::NodesContainerType::iterator node_it = rDestination_ModelPart.NodesBegin(); - node_it != rDestination_ModelPart.NodesEnd(); ++node_it) - { - Node<3>::Pointer pnode = *(node_it.base()); - pnode->GetValue(IS_VISITED) = 0.0; - } - //******************************************************************** - //Build an auxiliary ModelPart with all the PFEM free surface nodes - //******************************************************************** - PointVector list_of_erosionable_nodes; - - for(ModelPart::NodesContainerType::iterator node_it = rDestination_ModelPart.NodesBegin(); - node_it != rDestination_ModelPart.NodesEnd(); ++node_it) - { - - //PointType::Pointer pnode(new PointType(*node_it)); - Node<3>::Pointer pnode = *(node_it.base()); - - if(pnode->FastGetSolutionStepValue(IS_EROSIONABLE)==1.0 && pnode->FastGetSolutionStepValue(IS_STRUCTURE)!=1.0) - { - //putting the surface nodes of the destination_model part in an auxiliary list - list_of_erosionable_nodes.push_back( pnode ); - - WeakPointerVector< Node<3> >& neighb_nodes = pnode->GetValue(NEIGHBOUR_NODES); - - for( WeakPointerVector< Node<3> >::iterator j = neighb_nodes.begin(); j != neighb_nodes.end(); j++) - { - - - if(j->GetValue(IS_VISITED)==0.0 && j->FastGetSolutionStepValue(IS_STRUCTURE)!=1.0 && j->FastGetSolutionStepValue(IS_FREE_SURFACE)!=1.0) - { - list_of_erosionable_nodes.push_back( Node<3>::Pointer( *(j.base() ) ) ); - - - } - } - } - } - - //******************************************************************** - //Calculate velocity of the free surface nodes by direct variable interpolation - //******************************************************************** - //create a spatial database with the list of new nodes - unsigned int bucket_size = 20; - - tree nodes_tree(list_of_erosionable_nodes.begin(),list_of_erosionable_nodes.end(),bucket_size); - //work arrays - Node<3> work_point(0,0.0,0.0,0.0); - unsigned int MaximumNumberOfResults = 10000; - PointVector Results(MaximumNumberOfResults); - DistanceVector ResultsDistances(MaximumNumberOfResults); - - array_1d N; //Shape functions vector// - - double critical_vel2 = 0.0; - for (unsigned int i=0; i< TDim; i++) - critical_vel2 += rCriticalVel[i]*rCriticalVel[i]; - double fluidified_density = 1000.0; - double fluidified_viscosity = 0.000001; - int rCalculateDam = 0; - - //loop over all of the elements in the "old" list to perform the interpolation - for( ModelPart::ElementsContainerType::iterator el_it = rOrigin_ModelPart.ElementsBegin(); - el_it != rOrigin_ModelPart.ElementsEnd(); el_it++) - { - Geometry >&geom = el_it->GetGeometry(); - //check if the element is a fluid element or an element of the extrapolation domain - bool is_fluid = false; - unsigned int fluid_nodes_num = 0; -// double fluid_nu = 0.0; -// double fluid_rho = 0.0; - - for (unsigned int i = 0; i= TDim ) - { - is_fluid = true; - - //find the center and "radius" of the element - double xc, yc, zc, radius; - CalculateCenterAndSearchRadius( geom,xc,yc,zc, radius, N); - - //find all of the new nodes within the radius - int number_of_points_in_radius; - work_point.X() = xc; - work_point.Y() = yc; - - //look between the new nodes which of them is inside the radius of the circumscribed cyrcle - number_of_points_in_radius = nodes_tree.SearchInRadius(work_point, radius, Results.begin(), - ResultsDistances.begin(), MaximumNumberOfResults); - //check if inside - for( PointIterator it_found = Results.begin(); it_found != Results.begin() + number_of_points_in_radius; it_found++) - { - - bool is_inside = false; - //once we are sure the node in inside the circle we have to see if it is inside the triangle i.e. if all the Origin element shape functions are >1 - double is_visited = (*it_found)->GetValue(IS_VISITED); - is_inside = CalculatePosition(geom, (*it_found)->X(),(*it_found)->Y(),(*it_found)->Z(),N); - - //if the node falls inside the element interpolate - if(is_inside == true && is_visited != 1.0 && is_fluid == true) - { - - - array_1d InterpolatedVelocity; - - //Interpolating all the rVariables of the rOrigin_ModelPart to get their nodal value in the rDestination_ModelPart - Interpolate( el_it, N, *it_found , InterpolatedVelocity , VELOCITY ); - - double fluid_vel2 = 0.0; - // //Interpolated vel (not node real velocity) - for (unsigned int i=0; i< TDim; i++) - { - fluid_vel2 += InterpolatedVelocity[i] * InterpolatedVelocity[i]; - } - - //******************************************************************** - //Check if the velocity of PFEM free surface node is >= v_critical (Shield) - //******************************************************************** - - double dt = rDestination_ModelPart.GetProcessInfo()[DELTA_TIME]; - double coeff = 0.25 * fluid_nu * dt * fluid_rho * fluid_vel2; - - if(fluid_vel2 > critical_vel2 || (*it_found)->FastGetSolutionStepValue(FRICTION_COEFFICIENT) > 0.00001 ) - { - - -// //Starting the pfem solution - if(rCalculateDam == 0) - { - rCalculateDam = 1; -// KRATOS_WATCH("Solving PFEM stucture too ::::::::::::::::::::::::::::::::::::::::::::") - } - (*it_found)->FastGetSolutionStepValue(FRICTION_COEFFICIENT) += coeff; - - - } - - double volumetric_parameter = (*it_found)->FastGetSolutionStepValue(NODAL_H); - for(unsigned int i = 0; iFastGetSolutionStepValue(NODAL_H); - - - if( (*it_found)->FastGetSolutionStepValue(FRICTION_COEFFICIENT)>=(rCriticalEnergy * volumetric_parameter)) - { - (*it_found)->FastGetSolutionStepValue(VISCOSITY) = fluidified_viscosity; - (*it_found)->FastGetSolutionStepValue(DENSITY) = fluidified_density; - -// //In order not to allow the friction coefficient to increase too much - (*it_found)->FastGetSolutionStepValue(FRICTION_COEFFICIENT) = 100*(rCriticalEnergy * volumetric_parameter); - } - //} - } - } - } - } - - - //CHANGE DENSITY AND VISCOSITY IF ALL THE NODES OF AN ELEMENT ARE FREE SURFACE - for( ModelPart::ElementsContainerType::iterator el_it = rDestination_ModelPart.ElementsBegin(); - el_it != rDestination_ModelPart.ElementsEnd(); el_it++) - { - Geometry< Node<3> >& geom = el_it->GetGeometry(); - unsigned int n_freesurf_nodes = 0; - for(unsigned int i =0; i::Pointer pnode = *(node_it.base()); - WeakPointerVector< Node<3> >& neighb_nodes = pnode->GetValue(NEIGHBOUR_NODES); - for( WeakPointerVector< Node<3> >::iterator j = neighb_nodes.begin(); j != neighb_nodes.end(); j++) - { - if( j->FastGetSolutionStepValue(IS_FREE_SURFACE) == 1.0) - count ++; - } - if (count >= (TDim + 2)) - { - (pnode)->FastGetSolutionStepValue(VISCOSITY) = fluidified_viscosity; - (pnode)->FastGetSolutionStepValue(DENSITY) = fluidified_density; - } - } - - if(rCalculateDam == 1) - return true; - - return false; - - KRATOS_CATCH("") - -// KRATOS_WATCH("check erosion finished+++++++++++++++++++++++++++++++++++++++++++++++++") - } - - - - - - - void SetErosionableNodes( ModelPart& rModelPart) - { - KRATOS_TRY - -// for(ModelPart::NodesContainerType::iterator node_it = rModelPart.NodesBegin(); -// node_it != rModelPart.NodesEnd(); ++node_it) -// { -// //PointType::Pointer pnode(new PointType(*node_it)); -// Node<3>::Pointer pnode = *(node_it.base()); -// if(pnode->FastGetSolutionStepValue(IS_EROSIONABLE)==1.0) -// { -// WeakPointerVector< Node<3> >& neighb_nodes = pnode->GetValue(NEIGHBOUR_NODES); -// for( WeakPointerVector< Node<3> >::iterator j = neighb_nodes.begin(); j != neighb_nodes.end(); j++) -// { -// if(j->FastGetSolutionStepValue(IS_FREE_SURFACE) == 1.0) -// { -// j->FastGetSolutionStepValue(IS_EROSIONABLE) = 1.0; -// } -// -// } -// } -// } - KRATOS_CATCH("") - } - - /*@} */ - /**@name Acces */ - /*@{ */ - - - /*@} */ - /**@name Inquiry */ - /*@{ */ - - - /*@} */ - /**@name Friends */ - /*@{ */ - - - /*@} */ - -private: - ///@name Static Member rVariables - ///@{ - - - ///@} - ///@name Member rVariables - ///@{ - inline void CalculateCenterAndSearchRadius(Geometry >&geom, - double& xc, double& yc, double& zc, double& R, array_1d& N - ) - { - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - - - xc = 0.3333333333333333333*(x0+x1+x2); - yc = 0.3333333333333333333*(y0+y1+y2); - zc = 0.0; - - double R1 = (xc-x0)*(xc-x0) + (yc-y0)*(yc-y0); - double R2 = (xc-x1)*(xc-x1) + (yc-y1)*(yc-y1); - double R3 = (xc-x2)*(xc-x2) + (yc-y2)*(yc-y2); - - R = R1; - if(R2 > R) R = R2; - if(R3 > R) R = R3; - - R = 1.01 * sqrt(R); - } - //*************************************** - //*************************************** - inline void CalculateCenterAndSearchRadius(Geometry >&geom, - double& xc, double& yc, double& zc, double& R, array_1d& N - - ) - { - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double z0 = geom[0].Z(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double z1 = geom[1].Z(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - double z2 = geom[2].Z(); - double x3 = geom[3].X(); - double y3 = geom[3].Y(); - double z3 = geom[3].Z(); - - - xc = 0.25*(x0+x1+x2+x3); - yc = 0.25*(y0+y1+y2+y3); - zc = 0.25*(z0+z1+z2+z3); - - double R1 = (xc-x0)*(xc-x0) + (yc-y0)*(yc-y0) + (zc-z0)*(zc-z0); - double R2 = (xc-x1)*(xc-x1) + (yc-y1)*(yc-y1) + (zc-z1)*(zc-z1); - double R3 = (xc-x2)*(xc-x2) + (yc-y2)*(yc-y2) + (zc-z2)*(zc-z2); - double R4 = (xc-x3)*(xc-x3) + (yc-y3)*(yc-y3) + (zc-z3)*(zc-z3); - - R = R1; - if(R2 > R) R = R2; - if(R3 > R) R = R3; - if(R4 > R) R = R4; - - R = sqrt(R); - } - //*************************************** - //*************************************** - inline double CalculateVol( const double x0, const double y0, - const double x1, const double y1, - const double x2, const double y2 - ) - { - return 0.5*( (x1-x0)*(y2-y0)- (y1-y0)*(x2-x0) ); - } - //*************************************** - //*************************************** - inline double CalculateVol( const double x0, const double y0, const double z0, - const double x1, const double y1, const double z1, - const double x2, const double y2, const double z2, - const double x3, const double y3, const double z3 - ) - { - double x10 = x1 - x0; - double y10 = y1 - y0; - double z10 = z1 - z0; - - double x20 = x2 - x0; - double y20 = y2 - y0; - double z20 = z2 - z0; - - double x30 = x3 - x0; - double y30 = y3 - y0; - double z30 = z3 - z0; - - double detJ = x10 * y20 * z30 - x10 * y30 * z20 + y10 * z20 * x30 - y10 * x20 * z30 + z10 * x20 * y30 - z10 * y20 * x30; - return detJ*0.1666666666666666666667; - - //return 0.5*( (x1-x0)*(y2-y0)- (y1-y0)*(x2-x0) ); - } - //*************************************** - //*************************************** - inline bool CalculatePosition( Geometry >&geom, - const double xc, const double yc, const double zc, - array_1d& N - ) - { - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - - double area = CalculateVol(x0,y0,x1,y1,x2,y2); - double inv_area = 0.0; - if(area == 0.0) - { - KRATOS_THROW_ERROR(std::logic_error,"element with zero area found",""); - } - else - { - inv_area = 1.0 / area; - } - - - N[0] = CalculateVol(x1,y1,x2,y2,xc,yc) * inv_area; - N[1] = CalculateVol(x2,y2,x0,y0,xc,yc) * inv_area; - N[2] = CalculateVol(x0,y0,x1,y1,xc,yc) * inv_area; - - - if(N[0] >= 0.0 && N[1] >= 0.0 && N[2] >= 0.0 && N[0] <=1.0 && N[1]<= 1.0 && N[2] <= 1.0) //if the xc yc is inside the triangle return true - return true; - - return false; - } - - //*************************************** - //*************************************** - - inline bool CalculatePosition( Geometry >&geom, - const double xc, const double yc, const double zc, - array_1d& N - ) - { - - double x0 = geom[0].X(); - double y0 = geom[0].Y(); - double z0 = geom[0].Z(); - double x1 = geom[1].X(); - double y1 = geom[1].Y(); - double z1 = geom[1].Z(); - double x2 = geom[2].X(); - double y2 = geom[2].Y(); - double z2 = geom[2].Z(); - double x3 = geom[3].X(); - double y3 = geom[3].Y(); - double z3 = geom[3].Z(); - - double vol = CalculateVol(x0,y0,z0,x1,y1,z1,x2,y2,z2,x3,y3,z3); - - double inv_vol = 0.0; - if(vol < 0.0000000000001) - { - KRATOS_THROW_ERROR(std::logic_error,"element with zero vol found",""); - } - else - { - inv_vol = 1.0 / vol; - } - - N[0] = CalculateVol(x1,y1,z1,x3,y3,z3,x2,y2,z2,xc,yc,zc) * inv_vol; - N[1] = CalculateVol(x3,y3,z3,x0,y0,z0,x2,y2,z2,xc,yc,zc) * inv_vol; - N[2] = CalculateVol(x3,y3,z3,x1,y1,z1,x0,y0,z0,xc,yc,zc) * inv_vol; - N[3] = CalculateVol(x0,y0,z0,x1,y1,z1,x2,y2,z2,xc,yc,zc) * inv_vol; - - - if(N[0] >= 0.0 && N[1] >= 0.0 && N[2] >= 0.0 && N[3] >=0.0 && N[0] <= 1.0 && N[1] <= 1.0 && N[2] <= 1.0 && N[3] <=1.0) //if the xc yc zc is inside the tetrahedron return true - return true; - - return false; - } - - - static inline void Calculate_DN_DX(Geometry >&geom, - boost::numeric::ublas::bounded_matrix& DN_DX - ) - { - double x10 = geom[1].X() - geom[0].X(); - double y10 = geom[1].Y() - geom[0].Y(); - - double x20 = geom[2].X() - geom[0].X(); - double y20 = geom[2].Y() - geom[0].Y(); - - DN_DX(0,0) = -y20 + y10 ; - DN_DX(0,1) = x20 - x10; - DN_DX(1,0) = y20 ; - DN_DX(1,1) = -x20 ; - DN_DX(2,0) = -y10 ; - DN_DX(2,1) = x10 ; - } - - static inline void Calculate_DN_DX(Geometry >&geom, - boost::numeric::ublas::bounded_matrix& DN_DX - ) - { - double x10 = geom[1].X() - geom[0].X(); - double y10 = geom[1].Y() - geom[0].Y(); - double z10 = geom[1].Z() - geom[0].Z(); - - double x20 = geom[2].X() - geom[0].X(); - double y20 = geom[2].Y() - geom[0].Y(); - double z20 = geom[2].Z() - geom[0].Z(); - - double x30 = geom[3].X() - geom[0].X(); - double y30 = geom[3].Y() - geom[0].Y(); - double z30 = geom[3].Z() - geom[0].Z(); - - double detJ = x10 * y20 * z30 - x10 * y30 * z20 + y10 * z20 * x30 - y10 * x20 * z30 + z10 * x20 * y30 - z10 * y20 * x30; - - DN_DX(0,0) = -y20 * z30 + y30 * z20 + y10 * z30 - z10 * y30 - y10 * z20 + z10 * y20; - DN_DX(0,1) = -z20 * x30 + x20 * z30 - x10 * z30 + z10 * x30 + x10 * z20 - z10 * x20; - DN_DX(0,2) = -x20 * y30 + y20 * x30 + x10 * y30 - y10 * x30 - x10 * y20 + y10 * x20; - DN_DX(1,0) = y20 * z30 - y30 * z20; - DN_DX(1,1) = z20 * x30 - x20 * z30; - DN_DX(1,2) = x20 * y30 - y20 * x30; - DN_DX(2,0) = -y10 * z30 + z10 * y30; - DN_DX(2,1) = x10 * z30 - z10 * x30; - DN_DX(2,2) = -x10 * y30 + y10 * x30; - DN_DX(3,0) = y10 * z20 - z10 * y20; - DN_DX(3,1) = -x10 * z20 + z10 * x20; - DN_DX(3,2) = x10 * y20 - y10 * x20; - - DN_DX /= detJ; ; - } - - inline void CalculateNodalVelocityMatrix( Geometry >&geom, - boost::numeric::ublas::bounded_matrix& vel - ) - { - - //Nodal velocity - const array_1d vel0 = geom[0].FastGetSolutionStepValue(VELOCITY); - const array_1d vel1 = geom[1].FastGetSolutionStepValue(VELOCITY); - const array_1d vel2 = geom[2].FastGetSolutionStepValue(VELOCITY); - - - for(unsigned int j=0; j >&geom, - boost::numeric::ublas::bounded_matrix& vel - ) - { - - //Nodal velocity - const array_1d vel0 = geom[0].FastGetSolutionStepValue(VELOCITY); - const array_1d vel1 = geom[1].FastGetSolutionStepValue(VELOCITY); - const array_1d vel2 = geom[2].FastGetSolutionStepValue(VELOCITY); - const array_1d vel3 = geom[3].FastGetSolutionStepValue(VELOCITY); - - - for(unsigned int j=0; j& N, - Node<3>::Pointer pnode, - array_1d& Interpolated_velocity, - Variable >& rVariable) - { - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); -// KRATOS_WATCH(geom[0].Id()); -// KRATOS_WATCH(geom[1].Id()); -// KRATOS_WATCH(geom[2].Id()); -// unsigned int buffer_size = pnode->GetBufferSize(); - -// for(unsigned int step = 0; step& step_data = (pnode)->FastGetSolutionStepValue(rVariable , step); - //Reference or no reference???//CANCELLA - const array_1d node0_data = geom[0].FastGetSolutionStepValue(rVariable); -// KRATOS_WATCH(node0_data); - const array_1d node1_data = geom[1].FastGetSolutionStepValue(rVariable); -// KRATOS_WATCH(node1_data); - const array_1d node2_data = geom[2].FastGetSolutionStepValue(rVariable); -// KRATOS_WATCH(node2_data); - - - //copying this data in the position of the vector we are interested in - for(unsigned int j= 0; j< TDim; j++) - { -// step_data[j] = N[0]*node0_data[j] + N[1]*node1_data[j] + N[2]*node2_data[j]; - Interpolated_velocity[j] = N[0]*node0_data[j] + N[1]*node1_data[j] + N[2]*node2_data[j]; - - } -// KRATOS_WATCH(Interpolated_velocity); - -// } - pnode->GetValue(IS_VISITED) = 1.0; - } - - //projecting an array1D 3Dversion - void Interpolate( - ModelPart::ElementsContainerType::iterator el_it, - const array_1d& N, - Node<3>::Pointer pnode, - array_1d& Interpolated_velocity, - Variable >& rVariable) - { - //Geometry element of the rOrigin_ModelPart - Geometry< Node<3> >& geom = el_it->GetGeometry(); - -// unsigned int buffer_size = pnode->GetBufferSize(); - -// for(unsigned int step = 0; step& step_data = (pnode)->FastGetSolutionStepValue(rVariable , step);*/ - //Reference or no reference???//CANCELLA - const array_1d node0_data = geom[0].FastGetSolutionStepValue(rVariable); - const array_1d node1_data = geom[1].FastGetSolutionStepValue(rVariable); - const array_1d node2_data = geom[2].FastGetSolutionStepValue(rVariable); - const array_1d node3_data = geom[3].FastGetSolutionStepValue(rVariable); - - //copying this data in the position of the vector we are interested in - for(unsigned int j= 0; j< TDim; j++) - { - Interpolated_velocity[j] = N[0]*node0_data[j] + N[1]*node1_data[j] + N[2]*node2_data[j] + N[3]*node3_data[j]; - } -// } - pnode->GetValue(IS_VISITED) = 1.0; - } - - -// //scalar -// void Interpolate( -// ModelPart::ElementsContainerType::iterator el_it, -// const array_1d& N, -// Node<3>::Pointer pnode, -// Variable& rVariable) -// { -// //Geometry element of the rOrigin_ModelPart -// Geometry< Node<3> >& geom = el_it->GetGeometry(); -// -// unsigned int buffer_size = pnode->GetBufferSize(); -// //facendo un loop sugli step temporali step_data come salva i dati al passo anteriore? Cioś dove passiamo l'informazione ai nodi??? -// for(unsigned int step = 0; stepFastGetSolutionStepValue(rVariable , step); -// //Reference or no reference???//CANCELLA -// double& node0_data = geom[0].FastGetSolutionStepValue(rVariable , step); -// double& node1_data = geom[1].FastGetSolutionStepValue(rVariable , step); -// double& node2_data = geom[2].FastGetSolutionStepValue(rVariable , step); -// -// //copying this data in the position of the vector we are interested in -// -// step_data = N[0]*node0_data + N[1]*node1_data + N[2]*node2_data; -// -// } -// } - - -// inline void ClearVariables(ModelPart::NodesContainerType::iterator node_it , Variable >& rVariable) -// { -// array_1d& Aux_var = node_it->FastGetSolutionStepValue(rVariable, 0); -// -// noalias(Aux_var) = ZeroVector(3); -// -// } - - -// inline void ClearVariables(ModelPart::NodesContainerType::iterator node_it, Variable& rVariable) -// { -// double& Aux_var = node_it->FastGetSolutionStepValue(rVariable, 0); -// -// Aux_var = 0.0; -// -// } - - - - /*@} */ - /**@name Private Operators*/ - /*@{ */ - - - /*@} */ - /**@name Private Operations*/ - /*@{ */ - - - /*@} */ - /**@name Private Acces */ - /*@{ */ - - - /*@} */ - /**@name Private Inquiry */ - /*@{ */ - - - /*@} */ - /**@name Un accessible methods */ - /*@{ */ - - //ErosionUtils(void); - - //ErosionUtils(ErosionUtils& rSource); - - - /*@} */ - -}; /* Class ClassName */ - -/*@} */ - -/**@name Type Definitions */ -/*@{ */ - - -/*@} */ - -} /* namespace Kratos.*/ - -#endif /* KRATOS_NORMAL_TO_WALL_CALCULATIO_UTILS defined */ - diff --git a/applications/PFEMapplication/custom_utilities/exact_dt_estimate_utilities.h b/applications/PFEMapplication/custom_utilities/exact_dt_estimate_utilities.h deleted file mode 100644 index 35a503d6e84c..000000000000 --- a/applications/PFEMapplication/custom_utilities/exact_dt_estimate_utilities.h +++ /dev/null @@ -1,594 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: kazem $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_EXACT_DT_ESTIMATE_UTILITIES_INCLUDED ) -#define KRATOS_EXACT_DT_ESTIMATE_UTILITIES_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "includes/node.h" -#include "includes/element.h" -#include "includes/model_part.h" -#include "utilities/math_utils.h" -#include "includes/deprecated_variables.h" - -namespace Kratos -{ - -///@name Kratos Globals -///@{ - -///@} -///@name Type Definitions -///@{ - - -///@} -///@name Enum's -///@{ - -///@} -///@name Functions -///@{ - -///@} -///@name Kratos Classes -///@{ - -/// Short class definition. -/** Detail class definition. - calculate the nodal H for all the nodes depending on the min distance - of the neighbouring nodes. - - lonely nodes are given the average value of the H -*/ - -class ExactDtEstimateUtilities - -{ -public: - ///@name Type Definitions - ///@{ - - - ///@} - ///@name Life Cycle - ///@{ - - /// Default constructor. - - - ///@} - ///@name Operations - ///@{ - - double CubicExactDt(double dt_max, ModelPart& model_part, int dimension) - { - KRATOS_TRY - - double deltatime = dt_max; - double machin_zero = 1.0e-10; - - if(dimension == 2) - { - array_1d dv12, dv32; - array_1d dxprim12, dx32, dxprim32, dvprim12; - - double B, A, C; - - for(ModelPart::ElementsContainerType::iterator i = model_part.ElementsBegin(); - i!=model_part.ElementsEnd(); i++) - { - //calculating velocity and displacement vectors - Geometry< Node<3> >& geom = i->GetGeometry(); - noalias(dv32) = geom[2].FastGetSolutionStepValue(VELOCITY); - dv32 -= geom[1].FastGetSolutionStepValue(VELOCITY); - - noalias(dv12) = geom[0].FastGetSolutionStepValue(VELOCITY); - dv12 -= geom[1].FastGetSolutionStepValue(VELOCITY); - - dvprim12[0] = dv12[1]; - dvprim12[1] = -dv12[0]; - - dxprim12[0] = geom[0].Y() - geom[1].Y(); - dxprim12[1] = geom[1].X() - geom[0].X(); - - dx32[0] = geom[2].X() - geom[1].X(); - dx32[1] = geom[2].Y() - geom[1].Y(); - - dxprim32[0] = geom[1].Y() - geom[2].Y(); - dxprim32[1] = geom[2].X() - geom[1].X(); - - //Calculate A,B and C to calculate zero´s of dt - B = dv32[0]*dxprim12[0] + dv32[1]*dxprim12[1]; //inner_prod(dv32,dxprim12); - B += dv12[0]*dxprim32[0] + dv12[1]*dxprim32[1]; //inner_prod(dv12,dxprim32); - - A = dv32[0]*dvprim12[0] + dv32[1]*dvprim12[1]; //inner_prod(dv32,dvprim12); - - C = inner_prod(dx32, dxprim12); - - double zerodt = dt_max; - double Zdt1; - double Zdt2; - - if(A==0.0) - { - if(B != 0.0) zerodt = -1.0*C/B; - - } - - else - { - double delta = 0.0; - delta = B*B - 4.0*A*C; - if(delta > 0.0) - { - Zdt1 = (-B + sqrt(delta))/(2.0*A); - Zdt2 = (-B - sqrt(delta))/(2.0*A); - - //zerodt = -1.0; - if(Zdt1 > machin_zero) zerodt = Zdt1; - if(zerodt>Zdt2 && Zdt2 > machin_zero) zerodt = Zdt2; - } - - } - - //negative race means evert dt is acceptable - if(zerodt < machin_zero) zerodt = dt_max; - - //global check - if(zerodt < deltatime) - { - deltatime = zerodt; - KRATOS_WATCH("(((((((((((((((INSIDE ESTIMATE)))))))))))))))"); - } - } - - } - - if(dimension == 3) - { - for(ModelPart::ElementsContainerType::iterator i = model_part.ElementsBegin(); - i!=model_part.ElementsEnd(); i++) - { - Geometry< Node<3> >& geom = i->GetGeometry(); - int str = 0; - for(unsigned int ii=0; ii < geom.size(); ++ii) - if(geom[ii].FastGetSolutionStepValue(IS_STRUCTURE) == 1.0) - str++; - - - if(geom.size() == 4 && str==0) - { - array_1d DX1,DX2,DX3,V1,V2,V3; - - DX1[0] = geom[1].X() - geom[0].X(); - DX1[1] = geom[1].Y() - geom[0].Y(); - DX1[2] = geom[1].Z() - geom[0].Z(); - - DX2[0] = geom[2].X() - geom[0].X(); - DX2[1] = geom[2].Y() - geom[0].Y(); - DX2[2] = geom[2].Z() - geom[0].Z(); - - DX3[0] = geom[3].X() - geom[0].X(); - DX3[1] = geom[3].Y() - geom[0].Y(); - DX3[2] = geom[3].Z() - geom[0].Z(); - - noalias(V1) = geom[1].FastGetSolutionStepValue(VELOCITY); - V1 -= geom[0].FastGetSolutionStepValue(VELOCITY); - - noalias(V2) = geom[2].FastGetSolutionStepValue(VELOCITY); - V2 -= geom[0].FastGetSolutionStepValue(VELOCITY); - - noalias(V3) = geom[3].FastGetSolutionStepValue(VELOCITY); - V3 -= geom[0].FastGetSolutionStepValue(VELOCITY); - - //calculate coeficients of cubic equation using tensors - //C3*t³ + C2*t² + C1*t + C0 = 0.0 - array_1d Coeficients = ZeroVector(4); - array_1d roots = ZeroVector(3); - int num_Rroots; - double zerodt = dt_max; - - int Kronecker_delta = 1.0; - - for( int i = 0; i < 3; ++i ) - for( int j = 0; j < 3; ++j ) - for( int k = 0; k < 3; ++k ) - if( i!=j && j!=k && i!=k ) - { - Kronecker_delta = (j-i) * (k-i) * (k-j); - Kronecker_delta /= (abs(j-i)*abs(k-i)*abs(k-j)); - - Coeficients[0] += DX3[i]*DX1[j]*DX2[k]*Kronecker_delta; - - Coeficients[1] += (DX3[i]*(DX1[j]*V2[k] + DX2[k]*V1[j]) + DX1[j]*DX2[k]*V3[i])*Kronecker_delta; - - Coeficients[2] += (V3[i]*(DX1[j]*V2[k] + DX2[k]*V1[j]) + DX3[i]*V1[j]*V2[k])*Kronecker_delta; - - Coeficients[3] += (V3[i]*V1[j]*V2[k])*Kronecker_delta; - } - - CubicRoots(Coeficients, roots, num_Rroots); - - //roots are in ascending order - if(num_Rroots == 1 && roots[0] > machin_zero ) - zerodt = roots[0]; - - if(num_Rroots == 2) - { - if(roots[0] > machin_zero) - zerodt=roots[0]; - else if(roots[1] > machin_zero) - zerodt=roots[1]; - } - - if(num_Rroots == 3) - { - if(roots[0] > machin_zero) - zerodt=roots[0]; - else if(roots[1] > machin_zero) - zerodt=roots[1]; - else if(roots[2] > machin_zero) - zerodt=roots[2]; - } -// KRATOS_WATCH(Coeficients); -// KRATOS_WATCH(roots) -// KRATOS_WATCH(num_Rroots); -// KRATOS_WATCH(zerodt); - if(zerodt < deltatime ) - { - - //deltatime = zerodt; - KRATOS_WATCH("(((((((((((((((INSIDE ESTIMATE)))))))))))))))"); - KRATOS_WATCH(roots) - KRATOS_WATCH("Coordinates"); - array_1d first_out_pre; - MathUtils::CrossProduct(first_out_pre,DX1 , DX2); - KRATOS_WATCH("pre volume"); - KRATOS_WATCH(first_out_pre); - KRATOS_WATCH(DX1); - KRATOS_WATCH(DX2); - KRATOS_WATCH(DX3); - - KRATOS_WATCH(inner_prod(DX3,first_out_pre)); - DX1 += V1*deltatime; - DX2 += V2*deltatime; - DX3 += V3*deltatime; - array_1d first_out; - MathUtils::CrossProduct(first_out,DX1 , DX2); - - KRATOS_WATCH("Volume calculated"); - KRATOS_WATCH(inner_prod(DX3,first_out)); - - } - }//end of if 4 noded elements loop - }//end of element loop - - }//end of 3d loop - - return deltatime; - KRATOS_CATCH("") - } - - - - ///@} - ///@name Access - ///@{ - - - ///@} - ///@name Inquiry - ///@{ - - - ///@} - ///@name Input and output - ///@{ - - /// Turn back information as a string. - virtual std::string Info() const - { - return "ExactDtEstimateUtilities"; - } - - /// Print information about this object. - virtual void PrintInfo(std::ostream& rOStream) const - { - rOStream << "ExactDtEstimateUtilities"; - } - - /// Print object's data. - virtual void PrintData(std::ostream& rOStream) const - { - } - - - ///@} - ///@name Friends - ///@{ - - - ///@} - -protected: - ///@name Protected static Member Variables - ///@{ - - - ///@} - ///@name Protected member Variables - ///@{ - - - ///@} - ///@name Protected Operators - ///@{ - - - ///@} - ///@name Protected Operations - ///@{ - - - ///@} - ///@name Protected Access - ///@{ - - - ///@} - ///@name Protected Inquiry - ///@{ - - - ///@} - ///@name Protected LifeCycle - ///@{ - - - ///@} - -private: - ///@name Static Member Variables - ///@{ - - - ///@} - ///@name Member Variables - - - - //*********************************************************************** - //*********************************************************************** - void CubicRoots(array_1d A, array_1d& roots, int& num_Rroots) - { - KRATOS_TRY - const double PI = 3.1415926535897932; - const double THIRD = 1./3.; - double W, P, Q, DIS, PHI; - array_1d U; - - //define cubic root as statement function - // In C, the function is defined outside of the cubic fct - - // ====determine the degree of the polynomial ==== - - if (A[3] != 0.0) - { - //cubic problem - W = A[2]/A[3]*THIRD; - P = pow((A[1]/A[3]*THIRD - pow(W,2)),3); - Q = -.5*(2.0*pow(W,3)-(A[1]*W-A[0])/A[3] ); - DIS = pow(Q,2)+P; - if ( DIS < 0.0 ) - { - //three real solutions! - //Confine the argument of ACOS to the interval [-1;1]! - PHI = acos(MathUtils::Min(1.0,MathUtils::Max(-1.0,Q/sqrt(-P)))); - P=2.0*pow((-P),(5.e-1*THIRD)); - for (int i=0; i<3; i++) U[i] = P*cos((PHI+2*(double(i))*PI)*THIRD)-W; - roots[0] = MathUtils::Min(U[0], MathUtils::Min(U[1], U[2])); - roots[1] = MathUtils::Max(MathUtils::Min(U[0], U[1]),MathUtils::Max( MathUtils::Min(U[0], U[2]), MathUtils::Min(U[1], U[2]))); - roots[2] = MathUtils::Max(U[0], MathUtils::Max(U[1], U[2])); - num_Rroots = 3; - } - else - { - // only one real solution! - DIS = sqrt(DIS); - roots[0] = CBRT(Q+DIS)+CBRT(Q-DIS)-W; - num_Rroots=1; - } - } - else if (A[2] != 0.0) - { - // quadratic problem - P = 0.5*A[1]/A[2]; - DIS = pow(P,2)-A[0]/A[2]; - if (DIS > 0.0) - { - // 2 real solutions - roots[0] = -P - sqrt(DIS); - roots[1] = -P + sqrt(DIS); - num_Rroots=2; - } - else - { - // no real solution - num_Rroots=0; - } - } - else if (A[1] != 0.0) - { - //linear equation - roots[0] =A[0]/A[1]; - num_Rroots=1; - } - else - { - //no equation - num_Rroots=0; - } - /* - * ==== perform one step of a newton iteration in order to minimize - * round-off errors ==== - */ - for (int i=0; i 0.0) ret = 1; - if (Z < 0.0) ret = -1; - if (Z == 0.0) ret =0; - - return ret; - } - //*********************************************************************** - //*********************************************************************** - double CBRT(double Z) - { - double ret; - const double THIRD = 1./3.; - //define cubic root as statement function - //SIGN has different meanings in both C and Fortran - // Was unable to use the sign command of C, so wrote my own - // that why a new variable needs to be introduced that keeps track of the sign of - // SIGN is supposed to return a 1, -1 or 0 depending on what the sign of the argument is - ret = fabs(pow(fabs(Z),THIRD)) * signR(Z); - return ret; - } - ///@} - ///@name Private Operators - ///@{ - - ///@} - ///@name Private Operations - ///@{ - - - ///@} - ///@name Private Access - ///@{ - - - ///@} - ///@name Private Inquiry - ///@{ - - - ///@} - ///@name Un accessible methods - ///@{ - - /// Assignment operator. - ExactDtEstimateUtilities& operator=(ExactDtEstimateUtilities const& rOther); - - /// Copy constructor. - //ExactDtEstimateUtilities(ExactDtEstimateUtilities const& rOther); - - - ///@} - -}; // Class ExactDtEstimateUtilities - -///@} - -///@name Type Definitions -///@{ - - -///@} -///@name Input and output -///@{ - - -/// input stream function -inline std::istream& operator >> (std::istream& rIStream, - ExactDtEstimateUtilities& rThis); - -/// output stream function -inline std::ostream& operator << (std::ostream& rOStream, - const ExactDtEstimateUtilities& rThis) -{ - rThis.PrintInfo(rOStream); - rOStream << std::endl; - rThis.PrintData(rOStream); - - return rOStream; -} -///@} - - -} // namespace Kratos. - -#endif // KRATOS_FIND_NODAL_H_PROCESS_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_utilities/lagrangian_euler_solver.h b/applications/PFEMapplication/custom_utilities/lagrangian_euler_solver.h deleted file mode 100644 index 7ff2866f7c01..000000000000 --- a/applications/PFEMapplication/custom_utilities/lagrangian_euler_solver.h +++ /dev/null @@ -1,566 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-10-24 08:20:31 $ -// Revision: $Revision: 1.3 $ -// -// - - -#if !defined(KRATOS_LARANGIAN_FLUID_UTILITIES_INCLUDED ) -#define KRATOS_LARANGIAN_FLUID_UTILITIES_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "includes/model_part.h" -#include "includes/node.h" -#include "utilities/geometry_utilities.h" -#include "PFEM_application.h" - -namespace Kratos -{ - -template -class LagrangianEulerSolver -{ -public: - - typedef typename TSparseSpace::MatrixType TSystemMatrixType; - typedef typename TSparseSpace::VectorType TSystemVectorType; - typedef PointerVectorSet< Dof , IndexedObject> DofsArrayType; - - - LagrangianEulerSolver() {}; - ~LagrangianEulerSolver() {}; - - void Predict(ModelPart& model_part) - { - KRATOS_TRY - KRATOS_WATCH("quii"); - - //newmark coefficients - ProcessInfo& CurrentProcessInfo = model_part.GetProcessInfo(); - double DeltaTime = CurrentProcessInfo[DELTA_TIME]; - - - double AlphaBossak = 0.0; - double BetaNewmark = 0.25*(1.00-AlphaBossak)*(1.00-AlphaBossak); - double GammaNewmark = 0.5-AlphaBossak; - - double a0 = 1.0/(BetaNewmark*pow(DeltaTime,2)); - double a1 = GammaNewmark / (BetaNewmark*DeltaTime); - double a2 = 1.0/(BetaNewmark*DeltaTime); - double a3 = 1.0/(2.0*BetaNewmark) - 1.0; - double a4 = GammaNewmark/BetaNewmark - 1.0; - double a5 = DeltaTime*0.5*(GammaNewmark/BetaNewmark-2.0); -// double am = (1.0-AlphaBossak)/(BetaNewmark*pow(DeltaTime,2)); - - - //predicting end of step position - array_1d displacement_step_increment; //this is the displacement increment from step n to n+1 - for(ModelPart::NodesContainerType::iterator in = model_part.NodesBegin(); in!=model_part.NodesEnd(); in++) - { - - if(in->FastGetSolutionStepValue(IS_STRUCTURE) != 1) - { - array_1d& disp = in->FastGetSolutionStepValue(DISPLACEMENT); - array_1d& vel = in->FastGetSolutionStepValue(VELOCITY); - array_1d& acc = in->FastGetSolutionStepValue(ACCELERATION); - - const array_1d& disp_old = in->FastGetSolutionStepValue(DISPLACEMENT,1); - const array_1d& vel_old = in->FastGetSolutionStepValue(VELOCITY,1); - const array_1d& acc_old = in->FastGetSolutionStepValue(ACCELERATION,1); - - for(unsigned int j=0; jX() = in->X0() + disp[0]; - in->Y() = in->Y0() + disp[1]; - in->Z() = in->Z0() + disp[2]; - } - - } - KRATOS_CATCH(""); - - } - - - void SolveConvectionStep(ModelPart& model_part) - { - KRATOS_TRY - KRATOS_WATCH("quii"); - - //newmark coefficients - ProcessInfo& CurrentProcessInfo = model_part.GetProcessInfo(); - double DeltaTime = CurrentProcessInfo[DELTA_TIME]; - - - double AlphaBossak = 0.0; - double BetaNewmark = 0.25*(1.00-AlphaBossak)*(1.00-AlphaBossak); - double GammaNewmark = 0.5-AlphaBossak; - - double a0 = 1.0/(BetaNewmark*pow(DeltaTime,2)); - double a1 = GammaNewmark / (BetaNewmark*DeltaTime); - double a2 = 1.0/(BetaNewmark*DeltaTime); - double a3 = 1.0/(2.0*BetaNewmark) - 1.0; - double a4 = GammaNewmark/BetaNewmark - 1.0; - double a5 = DeltaTime*0.5*(GammaNewmark/BetaNewmark-2.0); - double am = (1.0-AlphaBossak)/(BetaNewmark*pow(DeltaTime,2)); - - //inverse coefficient for the acceleration term - double inverse_inertia_coeff = 1.0/am; - - //reset nodal area and press proj - for(ModelPart::NodesContainerType::iterator in = model_part.NodesBegin(); in!=model_part.NodesEnd(); in++) - { - in->FastGetSolutionStepValue(NODAL_AREA) = 0.0; - - array_1d& press_proj = in->FastGetSolutionStepValue(PRESS_PROJ); - for(unsigned int i=0; i aux; - boost::numeric::ublas::bounded_matrix DN_DX; - array_1d N; - - for(ModelPart::ElementsContainerType::iterator ie = model_part.ElementsBegin(); - ie!=model_part.ElementsEnd(); ie++) - { - //calculating shape functions values - Geometry< Node<3> >& geom = ie->GetGeometry(); - double Volume; - - GeometryUtils::CalculateGeometryData(geom,DN_DX,N,Volume); - - //calculate pressure at the gauss point - double p_avg = geom[0].FastGetSolutionStepValue(PRESSURE); - for(unsigned int i=1; i& press_proj = geom[I].FastGetSolutionStepValue(PRESS_PROJ); - for(unsigned int j=0; j delta_disp; //this is the displacement correction - array_1d displacement_step_increment; //this is the displacement increment from step n to n+1 - array_1d zero = ZeroVector(3); - for(ModelPart::NodesContainerType::iterator in = model_part.NodesBegin(); in!=model_part.NodesEnd(); in++) - { - const double nodal_area = in->FastGetSolutionStepValue(NODAL_AREA); - const double density = in->FastGetSolutionStepValue(DENSITY); - - //finisgin calculation of Minverse*G*p - array_1d& press_proj = in->FastGetSolutionStepValue(PRESS_PROJ); - if(nodal_area != 0.0) - press_proj *= (1.0/nodal_area); - else - noalias(press_proj) = zero; - - if(in->FastGetSolutionStepValue(IS_STRUCTURE) != 1) - { - const array_1d& body_force = in->FastGetSolutionStepValue(BODY_FORCE); - array_1d& disp = in->FastGetSolutionStepValue(DISPLACEMENT); - array_1d& vel = in->FastGetSolutionStepValue(VELOCITY); - array_1d& acc = in->FastGetSolutionStepValue(ACCELERATION); - - const array_1d& disp_old = in->FastGetSolutionStepValue(DISPLACEMENT,1); - const array_1d& vel_old = in->FastGetSolutionStepValue(VELOCITY,1); - const array_1d& acc_old = in->FastGetSolutionStepValue(ACCELERATION,1); - - - //calculating displacement increment (using newmark) - for(unsigned int j=0; jX() = in->X0() + disp[0]; - in->Y() = in->Y0() + disp[1]; - in->Z() = in->Z0() + disp[2]; - } - - } - KRATOS_CATCH(""); - - } - - //************************************************************************ - //************************************************************************ - void ConstructLaplacianSystem(ModelPart& model_part) - { - KRATOS_TRY - - //loop over nodes with neighbours - mDofSet = DofsArrayType(); - //mDofSet.resize(0); - mDofSet.reserve(model_part.Nodes().size() ); - - int tot_nnz=0; - int tot_row=0; - for (typename ModelPart::NodesContainerType::iterator it=model_part.NodesBegin(); it!=model_part.NodesEnd(); ++it) - { - if( (it->GetValue(NEIGHBOUR_NODES)).size() != 0 ) - { - mDofSet.push_back( it->pGetDof(PRESSURE) ); - tot_row += 1; - tot_nnz += (it->GetValue(NEIGHBOUR_NODES)).size()+1; - } - } - - //fills the DofList and give a unique progressive tag to each node - - int free_id = 0; - int fix_id = mDofSet.size(); - - for (typename DofsArrayType::iterator dof_iterator = mDofSet.begin(); dof_iterator != mDofSet.end(); ++dof_iterator) - if (dof_iterator->IsFixed()) - dof_iterator->SetEquationId(--fix_id); - else - dof_iterator->SetEquationId(free_id++); - - mEquationSystemSize = fix_id; - - std::vector< int > work_array; - work_array.reserve(1000); - - //guessing the total size of the matrix - mA.resize(mEquationSystemSize, mEquationSystemSize, tot_nnz); - - //getting the dof position - unsigned int dof_position = (model_part.NodesBegin())->GetDofPosition(PRESSURE); - - //building up the matrix graph row by row - unsigned int total_size = 0; - for (typename ModelPart::NodesContainerType::iterator it=model_part.NodesBegin(); it!=model_part.NodesEnd(); ++it) - { - unsigned int index_i = it->GetDof(PRESSURE,dof_position).EquationId(); - - if(index_i < mEquationSystemSize && (it->GetValue(NEIGHBOUR_NODES)).size() != 0) - { - WeakPointerVector< Node<3> >& neighb_nodes = it->GetValue(NEIGHBOUR_NODES); - - //filling the first neighbours list - work_array.push_back(index_i); - for( WeakPointerVector< Node<3> >::iterator i = neighb_nodes.begin(); i != neighb_nodes.end(); i++) - { - int index_j = i->GetDof(PRESSURE,dof_position).EquationId(); - work_array.push_back(index_j); - } - - //sorting the indices and elminating the duplicates - std::sort(work_array.begin(),work_array.end()); - typename std::vector::iterator new_end = std::unique(work_array.begin(),work_array.end()); - unsigned int number_of_entries = new_end - work_array.begin(); - - //filling up the matrix - for(unsigned int j=0; j DN_DX; - boost::numeric::ublas::bounded_matrix elemental_laplacian; - array_1d N; - array_1d local_indices; - array_1d rhs_contribution; - array_1d dp_vector; - - //getting the dof position - unsigned int dof_position = (model_part.NodesBegin())->GetDofPosition(PRESSURE); - - double aaa = 1.0/double(TDim+1.0); - - array_1d vg; - for(ModelPart::ElementsContainerType::iterator i = model_part.ElementsBegin(); - i!=model_part.ElementsEnd(); i++) - { - - Geometry< Node<3> >& geom = i->GetGeometry(); - - //calculating elemental values - double Volume; - GeometryUtils::CalculateGeometryData(geom, DN_DX, N, Volume); - - //determining elemental density and viscosity - double density = geom[0].FastGetSolutionStepValue(DENSITY); - for(int ii = 1; ii& v = geom[kk].FastGetSolutionStepValue(VELOCITY); - Gaux += DN_DX(kk,tt)*v[tt]; - } - } - noalias(rhs_contribution) = - Gaux * N; - - //applying dirichhlet - noalias(rhs_contribution) -= prod(elemental_laplacian,dp_vector); - - elemental_laplacian *= Volume; - rhs_contribution *= Volume; - - AssembleLHS(mA,elemental_laplacian,local_indices); - AssembleRHS(mb,rhs_contribution,local_indices); - - - - } - - //********************************** - //SOLVE PHASE - //********************************** - // KRATOS_WATCH(mA); - // KRATOS_WATCH(mb); - // KRATOS_WATCH(mDx); - linear_solver->Solve(mA,mDx,mb); - std::cout << *(linear_solver) << std::endl; - // KRATOS_WATCH(mDx); - - //********************************** - //UPDATE PRESSURES - //********************************** - for(typename DofsArrayType::iterator i_dof = mDofSet.begin() ; i_dof != mDofSet.end() ; ++i_dof) - { - if(i_dof->IsFree()) - { - i_dof->GetSolutionStepValue() += mDx[i_dof->EquationId()]; - } - } - - KRATOS_CATCH("") - } - - void ClearLaplacianSystem(ModelPart& model_part) - { - KRATOS_TRY - mDofSet = DofsArrayType(); - // mDofSet.resize(0); - mDx.resize(0,false); - mb.resize(0,false); - mA.resize(0,0,false); - - KRATOS_CATCH("") - } - - - - -private: - - unsigned int mEquationSystemSize; - TSystemVectorType mDx; - TSystemVectorType mb; - TSystemMatrixType mA; - DofsArrayType mDofSet; - - - - - - //************************************************************************** - void AssembleLHS( - TSystemMatrixType& A, - const boost::numeric::ublas::bounded_matrix& LHS_Contribution, - const array_1d& EquationId - ) - { - unsigned int local_size = LHS_Contribution.size1(); - - for (unsigned int i_local=0; i_local& RHS_Contribution, - const array_1d& EquationId - ) - { - unsigned int local_size = RHS_Contribution.size(); - - for (unsigned int i_local=0; i_local -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "includes/model_part.h" -#include "includes/node.h" -#include "custom_utilities/geometry_utilities.h" -#include "geometries/tetrahedra_3d_4.h" -#include "incompressible_fluid_application.h" - -namespace Kratos -{ -class PfemUtils -{ -public: - - - //********************************************************************************************** - //********************************************************************************************** - double EstimateDeltaTime(double dt_min, double dt_max, ModelPart::NodesContainerType& rNodes) - { - KRATOS_TRY - - array_1d xc, dist; - double deltatime = 1000.0; - array_1d vaux; - - for(ModelPart::NodesContainerType::iterator in = rNodes.begin(); in!=rNodes.end(); in++) - { - const array_1d& vc = in->FastGetSolutionStepValue(VELOCITY); - - if((in->GetValue(NEIGHBOUR_NODES)).size() != 0) - { - xc[0] = in->X(); - xc[1] = in->Y(); - xc[2] = in->Z(); - - double dt_node = 0.00; - for( WeakPointerVector< Node<3> >::iterator i = in->GetValue(NEIGHBOUR_NODES).begin(); - i != in->GetValue(NEIGHBOUR_NODES).end(); i++) - { - dist[0] = i->X(); - dist[1] = i->Y(); - dist[2] = i->Z(); - dist -= xc; - - noalias(vaux) = i->FastGetSolutionStepValue(VELOCITY); - noalias(vaux) -= vc; - double vnorm2 = inner_prod(vaux,vaux); - - if(vnorm2 != 0.0) - { - double nom = inner_prod(dist,vaux); - double dt_side = fabs(nom/vnorm2); - if(dt_side > dt_node) - dt_node = dt_side; - else if(dt_node < deltatime) - deltatime = dt_node; - } - } - } - } - - if(deltatime > dt_max) deltatime = dt_max; - else if (deltatime < dt_min) deltatime = dt_min; - - return deltatime; - - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - void MarkOuterNodes(const array_1d& corner1, const array_1d& corner2, - ModelPart::NodesContainerType& rNodes) - { - KRATOS_TRY; - - //add a big number to the id of the nodes to be erased - int n_erased = 0; - int added_id = 100000000; - double xmax, xmin, ymax,ymin, zmax, zmin; - - - - if(corner1[0] > corner2[0]) - { - xmax = corner1[0]; - xmin = corner2[0]; - } - else - { - xmax = corner2[0]; - xmin = corner1[0]; - } - - if(corner1[1] > corner2[1]) - { - ymax = corner1[1]; - ymin = corner2[1]; - } - else - { - ymax = corner2[1]; - ymin = corner1[1]; - } - - if(corner1[2] > corner2[2]) - { - zmax = corner1[2]; - zmin = corner2[2]; - } - else - { - zmax = corner2[2]; - zmin = corner1[2]; - } - - - - for(ModelPart::NodesContainerType::iterator in = rNodes.begin(); in!=rNodes.end(); in++) - { - bool erase = false; - double& x = in->X(); - double& y = in->Y(); - double& z = in->Z(); - - if(xxmax) erase = true; - else if(yymax) erase = true; - else if(zzmax) erase = true; - - if(erase == true) - { - n_erased += 1; - in->Set(TO_ERASE, true); - } - } - - KRATOS_CATCH("") - } - - - //********************************************************************************************** - //********************************************************************************************** - //calculates the ale spatial acceleration, taking in account both the spatial and the time dependent - //componenents acc = (v-vm)*dv/dx - template< int TDim > void CalculateSpatialALEAcceleration(ModelPart& ThisModelPart) - { - KRATOS_TRY; - - - double factor = 1.00/(TDim + 1); - const int nnodes = TDim+1; - - //reset the acceleration on the nodes - ModelPart::NodesContainerType& rNodes = ThisModelPart.Nodes(); - for(ModelPart::NodesContainerType::iterator in = rNodes.begin(); in!=rNodes.end(); in++) - { - noalias(in->FastGetSolutionStepValue(PRESSURE)) = 0.00; - } - - //compute the projection (first step - for(ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i!=ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node<3> >& geom = i->GetGeometry(); - double Volume; - - GeometryUtils::CalculateGeometryData(geom,DN_DX,N,Volume); - - double el_pressure = i->GetValue(PRESSURE); - - for(int I = 0; IFastGetSolutionStepValue(NODAL_AREA); - in->FastGetSolutionStepValue(PRESSURE) /= area; - } - - KRATOS_CATCH("") - } - - //********************************************************************************************** - //* //********************************************************************************************** - void CalculateNodalArea(ModelPart& ThisModelPart, int domain_size) - { - //set to zero the nodal area - for(ModelPart::NodesContainerType::iterator in = ThisModelPart.NodesBegin(); - in!=ThisModelPart.NodesEnd(); in++) - { - in->FastGetSolutionStepValue(NODAL_AREA) = 0.00; - } - - if(domain_size == 2) - { - double area = 0.0; - for(ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i!=ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node<3> >& geom = i->GetGeometry(); - - area = GeometryUtils::CalculateVolume2D(geom); - area *= 0.333333333333333333333333333; - - geom[0].FastGetSolutionStepValue(NODAL_AREA) += area; - geom[1].FastGetSolutionStepValue(NODAL_AREA) += area; - geom[2].FastGetSolutionStepValue(NODAL_AREA) += area; - } - } - else if(domain_size == 3) - { - for(ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i!=ThisModelPart.ElementsEnd(); i++) - { - double vol; - //calculating shape functions values - Geometry< Node<3> >& geom = i->GetGeometry(); - - vol = GeometryUtils::CalculateVolume3D(geom); - vol *= 0.25; - - geom[0].FastGetSolutionStepValue(NODAL_AREA) += vol; - geom[1].FastGetSolutionStepValue(NODAL_AREA) += vol; - geom[2].FastGetSolutionStepValue(NODAL_AREA) += vol; - geom[3].FastGetSolutionStepValue(NODAL_AREA) += vol; - } - } - //r - - - - } - - - //********************************************************************************************** - //********************************************************************************************** - //imposes the velocity that corresponds to a - void MoveLonelyNodes(ModelPart& ThisModelPart) - { - KRATOS_TRY; - - double Dt = ThisModelPart.GetProcessInfo()[DELTA_TIME]; - double accfactor = 0.5*Dt*Dt; - - array_1d DeltaDisp; - - const array_1d body_force = ThisModelPart.ElementsBegin()->GetProperties()[BODY_FORCE]; - for(ModelPart::NodeIterator i = ThisModelPart.NodesBegin() ; - i != ThisModelPart.NodesEnd() ; ++i) - { - if( - (i)->FastGetSolutionStepValue(IS_STRUCTURE) == 0 && //if it is not a wall node - (i)->GetValue(NEIGHBOUR_ELEMENTS).size() == 0 //and it is lonely - ) - { - //set to zero the pressure - (i)->FastGetSolutionStepValue(PRESSURE) = 0; - - const array_1d& old_vel = (i)->FastGetSolutionStepValue(VELOCITY,1); - array_1d& vel = (i)->FastGetSolutionStepValue(VELOCITY); - array_1d& acc = (i)->FastGetSolutionStepValue(ACCELERATION); - - noalias(acc) = body_force; - - noalias(vel) = old_vel; - noalias(vel) += Dt * acc ; - - //calculate displacements - noalias(DeltaDisp) = Dt * vel; - - array_1d& disp = i->FastGetSolutionStepValue(DISPLACEMENT); - noalias(disp) = i->FastGetSolutionStepValue(DISPLACEMENT,1); - noalias(disp) += DeltaDisp; - - } - - } - - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - double CalculateVolume(ModelPart& ThisModelPart, int domain_size) - { - KRATOS_TRY; - - //auxiliary vectors - double Atot = 0.00; - - if(domain_size == 2) - { - for(ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i!=ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node<3> >& geom = i->GetGeometry(); - - Atot += GeometryUtils::CalculateVolume2D(geom); - } - } - else if(domain_size == 3) - { - for(ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i!=ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node<3> >& geom = i->GetGeometry(); - - Atot += GeometryUtils::CalculateVolume3D(geom); - } - } - //return the total area - return Atot; - KRATOS_CATCH(""); - } - - - -private: - - //aux vars - static boost::numeric::ublas::bounded_matrix msJ; //local jacobian - static boost::numeric::ublas::bounded_matrix msJinv; //inverse jacobian - static array_1d msc; //center pos - static array_1d ms_rhs; //center pos - - - -}; - -} // namespace Kratos. - -#endif // KRATOS_LARANGIAN_FLUID_UTILITIES_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_utilities/lagrangian_utilities.h b/applications/PFEMapplication/custom_utilities/lagrangian_utilities.h deleted file mode 100644 index efda06b2f119..000000000000 --- a/applications/PFEMapplication/custom_utilities/lagrangian_utilities.h +++ /dev/null @@ -1,191 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_LAGRANGIAN_UTILITIES_INCLUDED ) -#define KRATOS_LAGRANGIAN_UTILITIES_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "includes/model_part.h" -#include "includes/deprecated_variables.h" -#include "includes/node.h" -#include "utilities/geometry_utilities.h" -#include "geometries/tetrahedra_3d_4.h" -#include "PFEM_application.h" - -namespace Kratos -{ -class LagrangianUtils -{ -public: - - - //********************************************************************************************** - //********************************************************************************************** - void ExplicitLagrangianPrediction(ModelPart& rModelPart) - { - KRATOS_TRY; - - array_1d delta_disp; - double dt = rModelPart.GetProcessInfo()[DELTA_TIME]; - ModelPart::NodesContainerType rNodes = rModelPart.Nodes(); - - for(ModelPart::NodesContainerType::iterator i = rNodes.begin(); i!=rNodes.end(); i++) - { - if(i->FastGetSolutionStepValue(IS_STRUCTURE) == 0) - { - noalias(delta_disp) = i->FastGetSolutionStepValue(VELOCITY); - delta_disp *= dt; - - noalias(i->FastGetSolutionStepValue(DISPLACEMENT)) += delta_disp; - } - } - - KRATOS_CATCH(""); - } - - //********************************************************************************************** - //********************************************************************************************** - // TAKE CARE! this is an eulerian step => the mesh velocity should be previously set to zero - void ImplicitLagrangianPrediction(ModelPart& rModelPart) - { - KRATOS_TRY; - - array_1d delta_disp; - double dt = rModelPart.GetProcessInfo()[DELTA_TIME]; - ModelPart::NodesContainerType rNodes = rModelPart.Nodes(); - - for(ModelPart::NodesContainerType::iterator i = rNodes.begin(); i!=rNodes.end(); i++) - { - if(i->FastGetSolutionStepValue(IS_STRUCTURE) == 0) - { - noalias(delta_disp) = i->FastGetSolutionStepValue(FRACT_VEL); - delta_disp *= dt; - - noalias(i->FastGetSolutionStepValue(DISPLACEMENT)) += delta_disp; - } - } - - KRATOS_CATCH(""); - } - - //********************************************************************************************** - //********************************************************************************************** - //calculates lagrangian displacements corrsponding to the first step of the fractional step solution - //assumes the FractionalStepVelocity at the old iteration to be saved in VAUX - void CalculateStep1DisplacementCorrection(ModelPart& rModelPart) - { - KRATOS_TRY; - - array_1d delta_disp; - double dt = rModelPart.GetProcessInfo()[DELTA_TIME]; - ModelPart::NodesContainerType rNodes = rModelPart.Nodes(); - - for(ModelPart::NodesContainerType::iterator i = rNodes.begin(); i!=rNodes.end(); i++) - { - if(i->FastGetSolutionStepValue(IS_STRUCTURE) == 0) - { - noalias(delta_disp) = i->FastGetSolutionStepValue(FRACT_VEL); - noalias(delta_disp) -= i->GetValue(VAUX); - delta_disp *= dt; - - noalias(i->FastGetSolutionStepValue(DISPLACEMENT)) += delta_disp; - } - } - - KRATOS_CATCH(""); - } - - //********************************************************************************************** - //********************************************************************************************** - - //calculates lagrangian displacements corrsponding to the first step of the fractional step solution - //assumes the FractionalStepVelocity at the old iteration to be saved in VAUX - void CalculateFinalDisplacementCorrection(ModelPart& rModelPart) - { - KRATOS_TRY; - - array_1d delta_disp; - double dt = rModelPart.GetProcessInfo()[DELTA_TIME]; - ModelPart::NodesContainerType rNodes = rModelPart.Nodes(); - - for(ModelPart::NodesContainerType::iterator i = rNodes.begin(); i!=rNodes.end(); i++) - { - if(i->FastGetSolutionStepValue(IS_STRUCTURE) == 0) - { - noalias(delta_disp) = i->FastGetSolutionStepValue(VELOCITY); - noalias(delta_disp) -= i->GetValue(VAUX); - delta_disp *= dt; - - noalias(i->FastGetSolutionStepValue(DISPLACEMENT)) += delta_disp; - } - } - - KRATOS_CATCH(""); - } -private: - -}; - -} // namespace Kratos. - -#endif // KRATOS_LAGRANGIAN_UTILITIES_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_utilities/nist_utilities.h b/applications/PFEMapplication/custom_utilities/nist_utilities.h deleted file mode 100644 index a98d01d9bfbf..000000000000 --- a/applications/PFEMapplication/custom_utilities/nist_utilities.h +++ /dev/null @@ -1,182 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.3 $ -// -// - - -#if !defined(KRATOS_NIST_UTILITIES_INCLUDED ) -#define KRATOS_NIST_UTILITIES_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "includes/model_part.h" -#include "includes/node.h" -#include "utilities/geometry_utilities.h" -#include "geometries/tetrahedra_3d_4.h" -#include "PFEM_application.h" - -namespace Kratos -{ -class NistUtils -{ -public: - - - //********************************************************************************************** - //********************************************************************************************** - /*void GenerateModelPart( - ModelPart& OriginModelPart , - ModelPart& DestinationModelPart, - Element const& rReferenceElement, - Condition const& rReferenceBoundaryCondition - ) - { - KRATOS_TRY; - - //assigning the nodes to the new model part - DestinationModelPart.rProperties()=OriginModelPart.rProperties(); - DestinationModelPart.Nodes().clear(); - DestinationModelPart.Nodes() = OriginModelPart.Nodes(); - - //generating the elements - int id = 1; - Properties::Pointer properties = OriginModelPart.GetMesh().pGetProperties(1); - for(ModelPart::ElementsContainerType::iterator iii = OriginModelPart.ElementsBegin(); iii != OriginModelPart.ElementsEnd(); iii++) - { - Geometry< Node<3> >& geom = iii->GetGeometry(); - Properties::Pointer properties = iii->pGetProperties(); - Element::Pointer p_element = rReferenceElement.Create(id, geom ,properties); - DestinationModelPart.Elements().push_back(p_element); - id = id + 1; - } - std::cout << "Elements are generated" << std::endl; - - //generating the conditions - id = 1; - for(ModelPart::ConditionsContainerType::iterator iii = OriginModelPart.ConditionsBegin(); iii != OriginModelPart.ConditionsEnd(); iii++) - { - Geometry< Node<3> >& geom = iii->GetGeometry(); - double nfree_surf = 0; - for(unsigned int k = 0; k 1) - { - Properties::Pointer properties = iii->pGetProperties(); - Condition::Pointer p_condition = rReferenceBoundaryCondition.Create(id, geom,properties); - DestinationModelPart.Conditions().push_back(p_condition); - id = id + 1; - } - } - std::cout << "Conditions are generated" << std::endl; - - KRATOS_CATCH(""); - } - */ - - //********************************************************************************************** - //********************************************************************************************** - void ApplyInitialTemperature( - ModelPart& ThisModelPart , - double wall_temperature - ) - { - KRATOS_TRY; - for(ModelPart::NodesContainerType::iterator in = ThisModelPart.NodesBegin(); - in!=ThisModelPart.NodesEnd(); in++) - { - if(in->FastGetSolutionStepValue(IS_STRUCTURE) == 1 && - (in->GetValue(NEIGHBOUR_ELEMENTS)).size() == 0 ) - { - in->FastGetSolutionStepValue(TEMPERATURE) = wall_temperature; - } - } - - KRATOS_CATCH(""); - } - - //********************************************************************************************** - //********************************************************************************************** - double FindFluidLevel( - ModelPart::NodesContainerType nodes - ) - { - KRATOS_TRY; - - double level = 0.00; - for(ModelPart::NodesContainerType::iterator in = nodes.begin(); - in!=nodes.end(); in++) - { - if( (in->GetValue(NEIGHBOUR_ELEMENTS)).size() != 0 ) - { - if( in->Y() > level) level = in->Y(); - } - } - return level; - - KRATOS_CATCH(""); - } - -private: - -}; - -} // namespace Kratos. - -#endif // KRATOS_NIST_UTILITIES_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_utilities/normal_to_wall_calculation_utils.h b/applications/PFEMapplication/custom_utilities/normal_to_wall_calculation_utils.h deleted file mode 100644 index c6b3b48070af..000000000000 --- a/applications/PFEMapplication/custom_utilities/normal_to_wall_calculation_utils.h +++ /dev/null @@ -1,269 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - - -/* ********************************************************* -* -* Last Modified by: $Author: pooyan $ -* Date: $Date: 2008-11-13 12:12:16 $ -* Revision: $Revision: 1.3 $ -* -* ***********************************************************/ -#include "includes/model_part.h" - -#if !defined(KRATOS_NORMAL_TO_WALL_CALCULATION_UTILS ) -#define KRATOS_NORMAL_TO_WALL_CALCULATION_UTILS - - -/* System includes */ - - -/* External includes */ - - -/* Project includes */ -#include "utilities/math_utils.h" - - -namespace Kratos -{ - -/**@name Kratos Globals */ -/*@{ */ - - -/*@} */ -/**@name Type Definitions */ -/*@{ */ - - -/*@} */ - - -/**@name Enum's */ -/*@{ */ - - -/*@} */ -/**@name Functions */ -/*@{ */ - - - -/*@} */ -/**@name Kratos Classes */ -/*@{ */ - -/** Short class definition. -Detail class definition. - - \URL[Example of use html]{ extended_documentation/no_ex_of_use.html} - - \URL[Example of use pdf]{ extended_documentation/no_ex_of_use.pdf} - - \URL[Example of use doc]{ extended_documentation/no_ex_of_use.doc} - - \URL[Example of use ps]{ extended_documentation/no_ex_of_use.ps} - - - \URL[Extended documentation html]{ extended_documentation/no_ext_doc.html} - - \URL[Extended documentation pdf]{ extended_documentation/no_ext_doc.pdf} - - \URL[Extended documentation doc]{ extended_documentation/no_ext_doc.doc} - - \URL[Extended documentation ps]{ extended_documentation/no_ext_doc.ps} - - -*/ -class NormalToWallCalculationUtils -{ -public: - /**@name Type Definitions */ - /*@{ */ - typedef ModelPart::NodesContainerType NodesArrayType; - typedef ModelPart::ConditionsContainerType ConditionsArrayType; - /*@} */ - /**@name Life Cycle - */ - /*@{ */ - - /** Constructor. - */ - - - /** Destructor. - */ - - /*@} */ - /**@name Operators - */ - /*@{ */ - - - /*@} */ - /**@name Operations */ - /*@{ */ - - //*********************************************************************** - //*********************************************************************** - //assumes the normals are already calculated - void CalculateNormalToWall( - ConditionsArrayType& rConditions, - int dimension) - { - KRATOS_TRY - - //resetting the normals - array_1d zero; - noalias(zero) = ZeroVector(3); - - for(ConditionsArrayType::iterator it = rConditions.begin(); it !=rConditions.end(); it++) - { - Element::GeometryType& rNodes = it->GetGeometry(); - for(unsigned int in = 0; in >& pGeometry = (it)->GetGeometry(); - - double coeff = 1.00/double(pGeometry.size()); - const array_1d& An = it->GetValue(NORMAL); - - //count the nodes on the boundary which are "of wall" - unsigned int structural_nodes = 0; - for(unsigned int i = 0; i -#include -#include - -// External includes -#include "includes/kratos_flags.h" - -// Project includes -#include "includes/define.h" -#include "includes/model_part.h" -#include "includes/deprecated_variables.h" -#include "includes/node.h" -#include "utilities/geometry_utilities.h" -#include "geometries/tetrahedra_3d_4.h" -#include "PFEM_application.h" -#include "utilities/openmp_utils.h" - -namespace Kratos -{ - -class PfemUtils -{ -public: - - //********************************************************************************************** - //********************************************************************************************** - - //functions to apply the boundary conditions - - void ApplyBoundaryConditions(ModelPart& ThisModelPart, int laplacian_type) - { - KRATOS_TRY; - - if (laplacian_type == 1) - { - //identify fluid nodes and mark as boundary the free ones - for (ModelPart::NodesContainerType::const_iterator in = ThisModelPart.NodesBegin(); in != ThisModelPart.NodesEnd(); in++) - { - //marking wet nodes - if (in->FastGetSolutionStepValue(IS_STRUCTURE)) - { - if ((in->GetValue(NEIGHBOUR_ELEMENTS)).size() != 0) - in->FastGetSolutionStepValue(IS_FLUID) = 1.0; - else //it is not anymore of fluid - in->FastGetSolutionStepValue(IS_FLUID) = 0.0; - } - //marking as free surface the lonely nodes - // else - if ((in->GetValue(NEIGHBOUR_ELEMENTS)).size() == 0) - in->FastGetSolutionStepValue(IS_BOUNDARY) = 1.0; - } - - //identify the free surface - for (ModelPart::NodeIterator i = ThisModelPart.NodesBegin(); - i != ThisModelPart.NodesEnd(); ++i) - { - //reset the free surface - i->FastGetSolutionStepValue(IS_FREE_SURFACE) = 0; - i->Free(PRESSURE); - - //identify the free surface and fix the pressure accordingly - if (i->FastGetSolutionStepValue(IS_BOUNDARY) != 0 - && - i->FastGetSolutionStepValue(IS_STRUCTURE) == 0) - { - i->FastGetSolutionStepValue(IS_FREE_SURFACE) = 1.0; - i->FastGetSolutionStepValue(PRESSURE) = 0.00; - i->Fix(PRESSURE); - } - } - - - } - else //case of discrete laplacian - { - //identify fluid nodes and mark as boundary the free ones - for (ModelPart::NodesContainerType::const_iterator in = ThisModelPart.NodesBegin(); in != ThisModelPart.NodesEnd(); in++) - { - in->Free(PRESSURE); - //marking wet nodes - if (in->FastGetSolutionStepValue(IS_STRUCTURE)) - { - if ((in->GetValue(NEIGHBOUR_ELEMENTS)).size() != 0) - in->FastGetSolutionStepValue(IS_FLUID) = 1.0; - else //it is not anymore of fluid - in->FastGetSolutionStepValue(IS_FLUID) = 0.0; - } - //marking as free surface the lonely nodes - // else - if ((in->GetValue(NEIGHBOUR_ELEMENTS)).size() == 0) - in->FastGetSolutionStepValue(IS_BOUNDARY) = 1.0; - - if ((in->GetValue(NEIGHBOUR_ELEMENTS)).size() == 0) - in->FastGetSolutionStepValue(PRESSURE) = 0.0; - } - - //identify the free surface - for (ModelPart::NodeIterator i = ThisModelPart.NodesBegin(); - i != ThisModelPart.NodesEnd(); ++i) - { - //reset the free surface - i->FastGetSolutionStepValue(IS_FREE_SURFACE) = 0; - - //identify the free surface and fix the pressure accordingly - if (i->FastGetSolutionStepValue(IS_BOUNDARY) != 0 - && - i->FastGetSolutionStepValue(IS_STRUCTURE) == 0) - { - i->FastGetSolutionStepValue(IS_FREE_SURFACE) = 1.0; - } - } - - - - } - - KRATOS_CATCH(""); - } - //********************************************************************************************** - //********************************************************************************************** - - void IdentifyFluidNodes(ModelPart& ThisModelPart) - { - KRATOS_TRY; - - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node < 3 > >& geom = i->GetGeometry(); - - for (unsigned int i = 0; i < geom.size(); i++) - geom[i].FastGetSolutionStepValue(IS_FLUID) = 1; - - } - KRATOS_CATCH(""); - } - - //********************************************************************************************** - //********************************************************************************************** - - void ApplyMinimalPressureConditions(ModelPart& r_model_part) - // void ApplyMinimalPressureConditions(std::vector< WeakPointerVector< Node<3> > >& connected_components) - { - KRATOS_TRY; - - /* //verify that the minimal conditions for pressure are applied - std::vector to_be_prescribed(connected_components.size()); - array_1d fixed_vel; - for(unsigned int i = 0; i >& node_list = connected_components[i]; - for( WeakPointerVector< Node<3> >::iterator in = node_list.begin(); - in != node_list.end(); in++) - { - //free the pressure - in->Free(PRESSURE); - - //cound boundary and fixed velocity nodes - if(in->FastGetSolutionStepValue(IS_BOUNDARY) == 1) - { - //count the nodes added - boundary_nodes += 1; - - //if it is structure add it to the fixed nodes - if(in->FastGetSolutionStepValue(IS_STRUCTURE) == 1) - prescribed_vel_nodes += 1; - - } - } - - //if all the boundary nodes have the velocity prescribed => it is needed to - //prescribe the pressure on 1 node - if(boundary_nodes == prescribed_vel_nodes) - { - bool one_is_prescribed = false; - for( WeakPointerVector< Node<3> >::iterator in = node_list.begin(); - in != node_list.end(); in++) - { - if( one_is_prescribed == false && - in->FastGetSolutionStepValue(IS_BOUNDARY) == 1 ) - { - std::cout << "fixed pressure on node " << in->Id() << std::endl; - one_is_prescribed = true; - in->Fix(PRESSURE); - } - } - } - }*/ - - - typedef Node < 3 > PointType; - typedef PointerVector PointVector; - //typedef PointVector::iterator PointIterator; - - //generate a container with the layers to be extrapolated - PointVector work_array; - work_array.reserve(r_model_part.Nodes().size()); - - //reset the counter - for (ModelPart::NodesContainerType::iterator inode = r_model_part.NodesBegin(); - inode != r_model_part.NodesEnd(); - inode++) - { - inode->GetValue(IS_VISITED) = 0.0; - } - - double connected_component_index = 1; - // PointIterator current_it = work_array.begin(); - unsigned int aux_index = 0; - unsigned int number_of_connected_components = 0; - for (ModelPart::NodesContainerType::iterator inode = r_model_part.NodesBegin(); - inode != r_model_part.NodesEnd(); - inode++) - { - - if (inode->GetValue(IS_VISITED) == 0.0 && (inode->GetValue(NEIGHBOUR_NODES)).size() != 0) //this node is not yet visited - it is in a new - { - number_of_connected_components++; - unsigned int n_free_boundaries = 0; - - //add the node to the work array - this node will be the "seed" of the partition - inode->GetValue(IS_VISITED) = connected_component_index; - work_array.push_back(Node < 3 > ::Pointer(*(inode.base()))); - - while (work_array.begin() + aux_index < work_array.end()) - { - - if ((work_array.begin() + aux_index)->FastGetSolutionStepValue(IS_FREE_SURFACE) == 1.0) - { - // KRATOS_WATCH("sono qui"); - n_free_boundaries++; - } - - //add its neighbours to the work array and mark them - WeakPointerVector< Node < 3 > >& neighb_nodes = (work_array.begin() + aux_index)->GetValue(NEIGHBOUR_NODES); - // KRATOS_WATCH(neighb_nodes.size() ); - for (WeakPointerVector< Node < 3 > >::iterator i = neighb_nodes.begin(); i != neighb_nodes.end(); i++) - { - if (i->GetValue(IS_VISITED) == 0.0) - { - //add the node to the work array - i->GetValue(IS_VISITED) = connected_component_index; - work_array.push_back(Node < 3 > ::Pointer(*(i.base()))); - } - - } - - //update the current counter - aux_index++; - } - // KRATOS_WATCH("ccc") - - //fix at least one pressure if needed (the pressure will be fixed on the "seed" node - if (n_free_boundaries == 0) - { - std::cout << "minimal pressure condition prescribed on node " << inode->Id() << std::endl; - inode->Fix(PRESSURE); - inode->FastGetSolutionStepValue(PRESSURE) = 0.0; - } - - //increase the component index counter - connected_component_index++; - } - - - } - std::cout << "number of connected components" << number_of_connected_components << std::endl; - KRATOS_CATCH(""); - } - - //********************************************************************************************** - //********************************************************************************************** - - double CFLdeltaT(double CFL, double max_dt, ModelPart& ThisModelPart) - { - KRATOS_TRY - - array_1d vel, pt0, pt1; - double max_dt_cfl = max_dt, a1, b1, a2, b2, X_target, Y_target, top_x, top_y, flag = 0.0; - - - - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - Geometry< Node < 3 > >& geom = i->GetGeometry(); - double this_node_dt; - - for (int ii = 0; ii < 3; ++ii) - { - vel = geom[ii].FastGetSolutionStepValue(VELOCITY); - double vel_square = inner_prod(vel, vel); - if (vel_square != 0.0 && geom[ii].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0) - { - a1 = a2 = b1 = b2 = 0.0; - top_x = geom[ii].X(); - top_y = geom[ii].Y(); - flag = 0.0; - //take line points - if (ii == 0) - { - pt1[0] = geom[1].X(); - pt1[1] = geom[1].Y(); - pt1[2] = geom[1].Z(); - - - pt0[0] = geom[2].X(); - pt0[1] = geom[2].Y(); - pt0[2] = geom[2].Z(); - } - else if (ii == 1) - { - pt1[0] = geom[0].X(); - pt1[1] = geom[0].Y(); - pt1[2] = geom[0].Z(); - - - pt0[0] = geom[2].X(); - pt0[1] = geom[2].Y(); - pt0[2] = geom[2].Z(); - } - else - { - pt1[0] = geom[1].X(); - pt1[1] = geom[1].Y(); - pt1[2] = geom[1].Z(); - - - pt0[0] = geom[0].X(); - pt0[1] = geom[0].Y(); - pt0[2] = geom[0].Z(); - } - - //check possible combination - if (vel[0] == 0.0) - { - if (pt1[0] == pt0[0]) flag = 1.0; - else - { - a2 = (pt1[1] - pt0[1]) / (pt1[0] - pt0[0]); - b2 = (pt1[0] * pt0[1] - pt1[1] * pt0[0]) / (pt1[0] - pt0[0]); - X_target = top_x; - Y_target = a2 * X_target + b2; - } - } - else - { - a1 = vel[1] / vel[0]; - b1 = top_y - a1*top_x; - - if (pt1[0] == pt0[0]) - { - X_target = pt0[0]; - Y_target = a1 * X_target + b1; - } - else - { - a2 = (pt1[1] - pt0[1]) / (pt1[0] - pt0[0]); - b2 = (pt1[0] * pt0[1] - pt1[1] * pt0[0]) / (pt1[0] - pt0[0]); - - if (a1 == a2) flag = 1.0; - else - { - X_target = (b2 - b1) / (a1 - a2); - Y_target = a2 * X_target + b2; - } - } - } - - if (flag == 0.0) - { - double l_square = (top_x - X_target)*(top_x - X_target) + (top_y - Y_target)*(top_y - Y_target); - this_node_dt = l_square / vel_square; - this_node_dt = CFL * sqrt(this_node_dt); - } - else this_node_dt = 1000000; - - - if (this_node_dt < max_dt_cfl) - { - max_dt_cfl = this_node_dt; - - } - - } - - - }//end of loop over element nodes - - }//end of loop over elements - return max_dt_cfl; - - KRATOS_CATCH(""); - } - //********************************************************************************************** - //********************************************************************************************** - - double ExactDtEstimate(double dt_max, ModelPart& ThisModelPart) - { - KRATOS_TRY - - array_1d dxprim12, dx32, dxprim32, dv12, dv32, dvprim12; - double deltatime = dt_max; - double B, A, C; - - - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - //calculating velocity and displacement vectors - Geometry< Node < 3 > >& geom = i->GetGeometry(); - noalias(dv32) = geom[2].FastGetSolutionStepValue(VELOCITY); - dv32 -= geom[1].FastGetSolutionStepValue(VELOCITY); - - noalias(dv12) = geom[0].FastGetSolutionStepValue(VELOCITY); - dv12 -= geom[1].FastGetSolutionStepValue(VELOCITY); - - dvprim12[0] = dv12[1]; - dvprim12[1] = -1 * dv12[0]; - - dxprim12[0] = geom[0].Y() - geom[1].Y(); - dxprim12[1] = geom[1].X() - geom[0].X(); - - dx32[0] = geom[2].X() - geom[1].X(); - dx32[1] = geom[2].Y() - geom[1].Y(); - - dxprim32[0] = geom[1].Y() - geom[2].Y(); - dxprim32[1] = geom[2].X() - geom[1].X(); - - //Calculate A,B and C to calculate zero´s of dt - B = inner_prod(dv32, dxprim12); - B += inner_prod(dv12, dxprim32); - - A = inner_prod(dv32, dvprim12); - - C = inner_prod(dx32, dxprim12); - - double zerodt = dt_max; - double Zdt1; - double Zdt2; - - if (A == 0.0) - { - if (B != 0.0) zerodt = -1.0 * C / B; - - } - else - { - double delta = 0.0; - delta = B * B - 4.0 * A*C; - if (delta > 0.0) - { - Zdt1 = (-1 * B + sqrt(delta)) / (2.0 * A); - Zdt2 = (-1 * B - sqrt(delta)) / (2.0 * A); - - //zerodt = -1.0; - if (Zdt1 > 0.0) zerodt = Zdt1; - if (zerodt > Zdt2 && Zdt2 > 0.0) zerodt = Zdt2; - } - - } - - //negative race means evert dt is acceptable - if (zerodt < 0.0) zerodt = dt_max; - - //global check - if (zerodt < deltatime) - { - deltatime = zerodt; - KRATOS_WATCH("(((((((((((((((INSIDE ESTIMATE)))))))))))))))"); - } - } - return deltatime; - - KRATOS_CATCH("") - } - //********************************************************************************************** - //********************************************************************************************** - - double EstimateDeltaTime(double dt_min, double dt_max, ModelPart& ThisModelPart) - { - KRATOS_TRY - - array_1d dx, dv; - double deltatime = dt_max; - double dvside, lside; - - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node < 3 > >& geom = i->GetGeometry(); - - for (unsigned int i1 = 0; i1 < geom.size() - 1; i1++) - { - for (unsigned int i2 = i1 + 1; i2 < geom.size(); i2++) - { - dx[0] = geom[i2].X() - geom[i1].X(); - dx[1] = geom[i2].Y() - geom[i1].Y(); - dx[2] = geom[i2].Z() - geom[i1].Z(); - - lside = inner_prod(dx, dx); - - noalias(dv) = geom[i2].FastGetSolutionStepValue(VELOCITY); - noalias(dv) -= geom[i1].FastGetSolutionStepValue(VELOCITY); - - dvside = inner_prod(dx, dv); - - double dt; - if (dvside < 0.0) //otherwise the side is "getting bigger" so the time step has not to be diminished - { - dt = fabs(lside / dvside); - if (dt < deltatime) deltatime = dt; - } - - } - } - } - - if (deltatime < dt_min) - { - std::cout << "ATTENTION dt_min is being used" << std::endl; - deltatime = dt_min; - } - //ATTENTION: following code is for testing purposes - else //check that the time step is nowhere bigger than hnode/vnode - { - double dt2 = deltatime*deltatime; - for (ModelPart::NodeIterator i = ThisModelPart.NodesBegin(); - i != ThisModelPart.NodesEnd(); ++i) - { - const array_1d & v = i->FastGetSolutionStepValue(VELOCITY); - const double& hnode = i->FastGetSolutionStepValue(NODAL_H); - - double norm_v2 = inner_prod(v, v); - - double dt_est = dt_max; - if (norm_v2 > 1e-20) - dt_est = hnode * hnode / norm_v2; - - if (dt_est < dt2) - dt2 = dt_est; - - } - double final_estimate = sqrt(dt2); - if (final_estimate < deltatime) - deltatime = final_estimate; - if (deltatime < dt_min) - { - std::cout << "ATTENTION dt_min is being used" << std::endl; - deltatime = dt_min; - } - } - - - - return deltatime; - - KRATOS_CATCH("") - } - /* double EstimateDeltaTime(double dt_min, double dt_max, ModelPart::NodesContainerType& rNodes) - { - KRATOS_TRY - - array_1d xc, dist; - double deltatime = 1000.0; - array_1d vaux; - - for(ModelPart::NodesContainerType::iterator in = rNodes.begin(); in!=rNodes.end(); in++) - { - const array_1d& vc = in->FastGetSolutionStepValue(VELOCITY); - - if((in->GetValue(NEIGHBOUR_NODES)).size() != 0) - { - xc[0] = in->X(); - xc[1] = in->Y(); - xc[2] = in->Z(); - - double dt_node = 0.00; - for( WeakPointerVector< Node<3> >::iterator i = in->GetValue(NEIGHBOUR_NODES).begin(); - i != in->GetValue(NEIGHBOUR_NODES).end(); i++) - { - dist[0] = i->X(); - dist[1] = i->Y(); - dist[2] = i->Z(); - dist -= xc; - - noalias(vaux) = i->FastGetSolutionStepValue(VELOCITY); - noalias(vaux) -= vc; - double vnorm2 = inner_prod(vaux,vaux); - - if(vnorm2 != 0.0) - { - double nom = inner_prod(dist,vaux); - double dt_side = fabs(nom/vnorm2); - if(dt_side > dt_node) - dt_node = dt_side; - else if(dt_node < deltatime) - deltatime = dt_node; - } - } - } - } - - if(deltatime > dt_max) deltatime = dt_max; - else if (deltatime < dt_min) deltatime = dt_min; - - return deltatime; - - KRATOS_CATCH("") - }*/ - - //********************************************************************************************** - //********************************************************************************************** - - void MarkOuterNodes(const array_1d & corner1, const array_1d & corner2, - ModelPart::NodesContainerType& rNodes) - { - KRATOS_TRY; - - //add a big number to the id of the nodes to be erased - int n_erased = 0; - double xmax, xmin, ymax, ymin, zmax, zmin; - - - - if (corner1[0] > corner2[0]) - { - xmax = corner1[0]; - xmin = corner2[0]; - } - else - { - xmax = corner2[0]; - xmin = corner1[0]; - } - - if (corner1[1] > corner2[1]) - { - ymax = corner1[1]; - ymin = corner2[1]; - } - else - { - ymax = corner2[1]; - ymin = corner1[1]; - } - - if (corner1[2] > corner2[2]) - { - zmax = corner1[2]; - zmin = corner2[2]; - } - else - { - zmax = corner2[2]; - zmin = corner1[2]; - } - - - - for (ModelPart::NodesContainerType::iterator in = rNodes.begin(); in != rNodes.end(); in++) - { - bool erase = false; - double& x = in->X(); - double& y = in->Y(); - double& z = in->Z(); - - if (x < xmin || x > xmax) erase = true; - else if (y < ymin || y > ymax) erase = true; - else if (z < zmin || z > zmax) erase = true; - - if (erase == true) - { - n_erased += 1; - in->Set(TO_ERASE, true); - } - } - - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - - void MarkExcessivelyCloseNodes(ModelPart::NodesContainerType& rNodes, const double admissible_distance_factor) - { - KRATOS_TRY; - KRATOS_WATCH("INSSSSSSSSSSIDE MARK EXCESSIVELY"); - - const double fact2 = admissible_distance_factor*admissible_distance_factor; - - - - ModelPart::NodeIterator NodesBegin = rNodes.begin(); - int size = rNodes.size(); - ModelPart::NodeIterator in; - #pragma omp parallel for firstprivate(size,NodesBegin),private(in) - for (int k = 0; k < size; k++) - { - in = NodesBegin + k; - - if (in->FastGetSolutionStepValue(IS_STRUCTURE) == 0) //if it is not a wall node i can erase - { - double hnode2 = in->FastGetSolutionStepValue(NODAL_H); - hnode2 *= hnode2; //take the square - - //loop on neighbours and erase if they are too close - for (WeakPointerVector< Node < 3 > >::iterator i = in->GetValue(NEIGHBOUR_NODES).begin(); - i != in->GetValue(NEIGHBOUR_NODES).end(); i++) - { - if (static_cast (i->Is(TO_ERASE)) == false) //we can erase the current node only if the neighb is not to be erased - { - double dx = i->X() - in->X(); - double dy = i->Y() - in->Y(); - double dz = i->Z() - in->Z(); - - double dist2 = dx * dx + dy * dy + dz*dz; - - if (dist2 < fact2 * hnode2) - in->Set(TO_ERASE, true); - } - } - } - } - // } - - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - // bool AlphaShape3D(double alpha_param, Tetrahedra3D4 >& pgeom) - // { - // KRATOS_TRY - // - // double x0 = pgeom[0].X(); - // double x1 = pgeom[1].X(); - // double x2 = pgeom[2].X(); - // double x3 = pgeom[3].X(); - // - // double y0 = pgeom[0].Y(); - // double y1 = pgeom[1].Y(); - // double y2 = pgeom[2].Y(); - // double y3 = pgeom[3].Y(); - // - // double z0 = pgeom[0].Z(); - // double z1 = pgeom[1].Z(); - // double z2 = pgeom[2].Z(); - // double z3 = pgeom[3].Z(); - // - // //calculation of the jacobian - // msJ(0,0) = x1-x0; msJ(0,1) = y1-y0; msJ(0,2) = z1-z0; - // msJ(1,0) = x2-x0; msJ(1,1) = y2-y0; msJ(1,2) = z2-z0; - // msJ(2,0) = x3-x0; msJ(2,1) = y3-y0; msJ(2,2) = z3-z0; - // - // //inverse of the jacobian - // //first column - // msJinv(0,0) = msJ(1,1)*msJ(2,2) - msJ(1,2)*msJ(2,1); - // msJinv(1,0) = -msJ(1,0)*msJ(2,2) + msJ(1,2)*msJ(2,0); - // msJinv(2,0) = msJ(1,0)*msJ(2,1) - msJ(1,1)*msJ(2,0); - // //second column - // msJinv(0,1) = -msJ(0,1)*msJ(2,2) + msJ(0,2)*msJ(2,1); - // msJinv(1,1) = msJ(0,0)*msJ(2,2) - msJ(0,2)*msJ(2,0); - // msJinv(2,1) = -msJ(0,0)*msJ(2,1) + msJ(0,1)*msJ(2,0); - // //third column - // msJinv(0,2) = msJ(0,1)*msJ(1,2) - msJ(0,2)*msJ(1,1); - // msJinv(1,2) = -msJ(0,0)*msJ(1,2) + msJ(0,2)*msJ(1,0); - // msJinv(2,2) = msJ(0,0)*msJ(1,1) - msJ(0,1)*msJ(1,0); - // //calculation of determinant (of the input matrix) - // - // double detJ = msJ(0,0)*msJinv(0,0) - // + msJ(0,1)*msJinv(1,0) - // + msJ(0,2)*msJinv(2,0); - // - // //calculate average h - // double h; - // h = pgeom[0].FastGetSolutionStepValue(NODAL_H); - // h += pgeom[1].FastGetSolutionStepValue(NODAL_H); - // h += pgeom[2].FastGetSolutionStepValue(NODAL_H); - // h += pgeom[3].FastGetSolutionStepValue(NODAL_H); - // h *= 0.25; - // - // if(detJ < 1e-6 * h*h*h) //this is a sliver and we will remove it - // { - // return false; - // } - // else - // { - // - // double x0_2 = x0*x0 + y0*y0 + z0*z0; - // double x1_2 = x1*x1 + y1*y1 + z1*z1; - // double x2_2 = x2*x2 + y2*y2 + z2*z2; - // double x3_2 = x3*x3 + y3*y3 + z3*z3; - // - // //finalizing the calculation of the inverted matrix - // msJinv /= detJ; - // - // //calculating the RHS - // ms_rhs[0] = 0.5*(x1_2 - x0_2); - // ms_rhs[1] = 0.5*(x2_2 - x0_2); - // ms_rhs[2] = 0.5*(x3_2 - x0_2); - // - // //calculate position of the center - // noalias(msc) = prod(msJinv,ms_rhs); - // - // //calculate radius - // double radius = pow(msc[0] - x0,2); - // radius += pow(msc[1] - y0,2); - // radius += pow(msc[2] - z0,2); - // radius = sqrt(radius); - // - // if (radius < h*alpha_param) - // { - // if(detJ < 1e-4 * h*h*h) //this is a sliver and we will remove it even if it would be acceptable - // { - // std::cout << "removed sliver = " << detJ << std::endl; - // return false; - // } - // else - // return true; - // } - // else - // { - // return false; - // } - // } - // KRATOS_CATCH("") - // } - - //********************************************************************************************** - //********************************************************************************************** - //calculates the ale spatial acceleration, taking in account both the spatial and the time dependent - //componenents acc = (v-vm)*dv/dx - - template< int TDim > void CalculateSpatialALEAcceleration(ModelPart& ThisModelPart) - { - KRATOS_TRY; - - //auxiliary vectors - boost::numeric::ublas::bounded_matrix DN_DX; - array_1d N; - array_1d vaux3; - array_1d vgauss; - array_1d aux; - const array_1d zero = ZeroVector(TDim); - const array_1d zero3 = ZeroVector(3); - boost::numeric::ublas::bounded_matrix dv_dx; - double factor = 1.00 / (TDim + 1); - const int nnodes = TDim + 1; - - //reset the acceleration on the nodes - ModelPart::NodesContainerType& rNodes = ThisModelPart.Nodes(); - for (ModelPart::NodesContainerType::iterator in = rNodes.begin(); in != rNodes.end(); in++) - { - noalias(in->FastGetSolutionStepValue(ACCELERATION)) = zero3; - } - - //compute the projection (first step - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node < 3 > >& geom = i->GetGeometry(); - double Volume; - - GeometryUtils::CalculateGeometryData(geom, DN_DX, N, Volume); - - //constructing the gradient - noalias(dv_dx) = ZeroMatrix(TDim, TDim); - noalias(vaux3) = zero3; - for (int I = 0; I < nnodes; I++) - { - array_1d & v = geom[I].FastGetSolutionStepValue(VELOCITY); - noalias(vaux3) += v; - noalias(vaux3) -= geom[I].FastGetSolutionStepValue(MESH_VELOCITY); - for (int i = 0; i < TDim; i++) - for (int j = 0; j < TDim; j++) - dv_dx(i, j) += DN_DX(I, j) * v[i]; - } - for (int iii = 0; iii < TDim; iii++) - vgauss[iii] = factor * vaux3[iii]; - // vgauss *= factor; - - noalias(aux) = prod(dv_dx, vgauss); - - //project vgauss * dv/dx on the nodes - for (int I = 0; I < nnodes; I++) - { - array_1d & acc = geom[I].FastGetSolutionStepValue(ACCELERATION); - for (int iii = 0; iii < TDim; iii++) - acc[iii] += N[I] * Volume * aux[iii]; - //noalias(acc) += N[I] * Volume * aux; - } - } - - //finalize the calculation of the convective acceleration - for (ModelPart::NodesContainerType::iterator in = rNodes.begin(); in != rNodes.end(); in++) - { - array_1d & acc = in->FastGetSolutionStepValue(ACCELERATION); - acc *= in->FastGetSolutionStepValue(DENSITY); - double mass = in->FastGetSolutionStepValue(NODAL_MASS); - acc /= mass; - } - - KRATOS_CATCH("") - } - - //********************************************************************************************** - //* //********************************************************************************************** - - void CalculateNodalMass(ModelPart& ThisModelPart, int domain_size) - { - //set to zero the nodal area - for (ModelPart::NodesContainerType::iterator in = ThisModelPart.NodesBegin(); - in != ThisModelPart.NodesEnd(); in++) - { - in->FastGetSolutionStepValue(NODAL_MASS) = 0.00; - } - - if (domain_size == 2) - { - double mass = 0.0; - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node < 3 > >& geom = i->GetGeometry(); - - double density = geom[0].FastGetSolutionStepValue(DENSITY) - + geom[1].FastGetSolutionStepValue(DENSITY) - + geom[2].FastGetSolutionStepValue(DENSITY); - density *= 0.333333333333333333333333333; - - mass = GeometryUtils::CalculateVolume2D(geom); //calculating the elemental area - mass *= 0.333333333333333333333333333 * density; - - geom[0].FastGetSolutionStepValue(NODAL_MASS) += mass; - geom[1].FastGetSolutionStepValue(NODAL_MASS) += mass; - geom[2].FastGetSolutionStepValue(NODAL_MASS) += mass; - } - } - else if (domain_size == 3) - { - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - double mass; - //calculating shape functions values - Geometry< Node < 3 > >& geom = i->GetGeometry(); - - double density = geom[0].FastGetSolutionStepValue(DENSITY) - + geom[1].FastGetSolutionStepValue(DENSITY) - + geom[2].FastGetSolutionStepValue(DENSITY) - + geom[3].FastGetSolutionStepValue(DENSITY); - density *= 0.25; - - mass = GeometryUtils::CalculateVolume3D(geom); - mass *= 0.25 * density; - - geom[0].FastGetSolutionStepValue(NODAL_MASS) += mass; - geom[1].FastGetSolutionStepValue(NODAL_MASS) += mass; - geom[2].FastGetSolutionStepValue(NODAL_MASS) += mass; - geom[3].FastGetSolutionStepValue(NODAL_MASS) += mass; - } - } - - //prevent zero mass - for (ModelPart::NodesContainerType::iterator in = ThisModelPart.NodesBegin(); - in != ThisModelPart.NodesEnd(); in++) - { - if (in->FastGetSolutionStepValue(NODAL_MASS) == 0.00) - { - in->FastGetSolutionStepValue(NODAL_MASS) = in->FastGetSolutionStepValue(DENSITY); - } - } - - - } - - //********************************************************************************************** - //********************************************************************************************** - - void QuasiLagrangianMove(ModelPart& ThisModelPart) - { - KRATOS_TRY; - - double dt = ThisModelPart.GetProcessInfo()[DELTA_TIME]; - double accfactor = 0.5 * dt*dt; - array_1d acc; - for (ModelPart::NodesContainerType::iterator in = ThisModelPart.NodesBegin(); - in != ThisModelPart.NodesEnd(); in++) - { - if ((in->GetValue(NEIGHBOUR_ELEMENTS)).size() != 0 - && in->FastGetSolutionStepValue(IS_STRUCTURE) != 1) - { - array_1d & vel = in->FastGetSolutionStepValue(VELOCITY); - array_1d & vel_old = in->FastGetSolutionStepValue(VELOCITY, 1); - //calculating time derivative of velocity - noalias(acc) = vel; - noalias(acc) -= vel_old; - acc /= dt; - - //adding the spatial acceleration to the acceleration - noalias(acc) += in->FastGetSolutionStepValue(ACCELERATION, 1); - - //calculate displacements - array_1d & disp = in->FastGetSolutionStepValue(DISPLACEMENT); - noalias(disp) = in->FastGetSolutionStepValue(DISPLACEMENT, 1); - noalias(disp) += dt * vel; - noalias(disp) += accfactor * acc; - - //calculate corresponding velocity - noalias(vel) = vel_old; - noalias(vel) += dt * acc; - - - - //calculate mesh velocity - //array_1d& mesh_vel = in->FastGetSolutionStepValue(MESH_VELOCITY); - //noalias(mesh_vel) = disp; - //noalias(mesh_vel) -= in->FastGetSolutionStepValue(DISPLACEMENT,1); - //mesh_vel /= dt; - } - } - - KRATOS_CATCH("") - } - - - //********************************************************************************************** - //********************************************************************************************** - - void Predict(ModelPart& ThisModelPart) - { - KRATOS_TRY; - - double dt = ThisModelPart.GetProcessInfo()[DELTA_TIME]; - array_1d acc; - for (ModelPart::NodesContainerType::iterator in = ThisModelPart.NodesBegin(); - in != ThisModelPart.NodesEnd(); in++) - { - if ((in->GetValue(NEIGHBOUR_ELEMENTS)).size() != 0 - && in->FastGetSolutionStepValue(IS_STRUCTURE) != 1) - { - //calculate displacements - array_1d & disp = in->FastGetSolutionStepValue(DISPLACEMENT); - noalias(disp) = in->FastGetSolutionStepValue(DISPLACEMENT, 1); - noalias(disp) += dt * in->FastGetSolutionStepValue(VELOCITY, 1); - } - } - - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - //imposes the velocity that corresponds to a - - void MoveLonelyNodes(ModelPart& ThisModelPart) - { - KRATOS_TRY; - - double Dt = ThisModelPart.GetProcessInfo()[DELTA_TIME]; - - array_1d DeltaDisp, acc; - - KRATOS_WATCH("in MoveLonelyNodes") - - //const array_1d body_force = ThisModelPart.ElementsBegin()->GetProperties()[BODY_FORCE]; - for (ModelPart::NodeIterator i = ThisModelPart.NodesBegin(); - i != ThisModelPart.NodesEnd(); ++i) - { - if ( - (i)->FastGetSolutionStepValue(IS_STRUCTURE) == 0 && //if it is not a wall node - (i)->GetValue(NEIGHBOUR_ELEMENTS).size() == 0 //and it is lonely - ) - { - // KRATOS_WATCH(i->Id()); - //set to zero the pressure - (i)->FastGetSolutionStepValue(PRESSURE) = 0; - - const array_1d & old_vel = (i)->FastGetSolutionStepValue(VELOCITY, 1); - array_1d & vel = (i)->FastGetSolutionStepValue(VELOCITY); - //array_1d& acc = (i)->FastGetSolutionStepValue(ACCELERATION); - - noalias(acc) = (i)->FastGetSolutionStepValue(BODY_FORCE); - - noalias(vel) = old_vel; - noalias(vel) += Dt * acc; - - //calculate displacements - noalias(DeltaDisp) = Dt * vel; - - array_1d & disp = i->FastGetSolutionStepValue(DISPLACEMENT); - noalias(disp) = i->FastGetSolutionStepValue(DISPLACEMENT, 1); - noalias(disp) += DeltaDisp; - - } - - } - - KRATOS_CATCH("") - } - //********************************************************************************************* - //********************************************************************************************* - - void MarkNodesTouchingWall(ModelPart& ThisModelPart, int domain_size, double factor) - { - KRATOS_TRY; - - if (domain_size == 2) - { - - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - double n_str = 0; - - //counting number on nodes at the wall - Geometry< Node < 3 > >& geom = i->GetGeometry(); - n_str = geom[0].FastGetSolutionStepValue(IS_BOUNDARY); - n_str += geom[1].FastGetSolutionStepValue(IS_BOUNDARY); - n_str += geom[2].FastGetSolutionStepValue(IS_BOUNDARY); - //if two walls are at the wall, we check if the third node is close to it or not by passing the alpha-shape - if (n_str == 2.0) - { - boost::numeric::ublas::bounded_matrix sort_coord = ZeroMatrix(3, 2); - int cnt = 1; - for (int i = 0; i < 3; ++i) - if (geom[i].FastGetSolutionStepValue(IS_BOUNDARY) == 0.0) - { - sort_coord(0, 0) = geom[i].X(); - sort_coord(0, 1) = geom[i].Y(); - } - else - { - sort_coord(cnt, 0) = geom[i].X(); - sort_coord(cnt, 1) = geom[i].Y(); - cnt++; - } - - array_1d vec1 = ZeroVector(2); - array_1d vec2 = ZeroVector(2); - - vec1[0] = sort_coord(0, 0) - sort_coord(1, 0); - vec1[1] = sort_coord(0, 1) - sort_coord(1, 1); - - vec2[0] = sort_coord(2, 0) - sort_coord(1, 0); - vec2[1] = sort_coord(2, 1) - sort_coord(1, 1); - - double outer_prod = 0.0; - outer_prod = vec2[1] * vec1[0] - vec1[1] * vec2[0]; - - double length_measure = 0.0; - length_measure = vec2[0] * vec2[0] + vec2[1] * vec2[1]; - length_measure = sqrt(length_measure); - outer_prod /= length_measure; - - //KRATOS_WATCH(fabs(outer_prod)); - // RATOS_WATCH(factor*length_measure); - - if (fabs(outer_prod) < factor * length_measure) - { - for (int i = 0; i < 3; i++) - { - //if thats not the wall node, remove it - if (geom[i].FastGetSolutionStepValue(IS_BOUNDARY) == 0.0) - { - geom[i].Set(TO_ERASE, true); - //KRATOS_WATCH("NODE TOUCHING THE WALL - WILL BE ERASED!!!!") - } - } - } - } - - } - } - else - { - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - double n_str = 0; - - //counting number on nodes at the wall - Geometry< Node < 3 > >& geom = i->GetGeometry(); - if (geom.size() == 4) - { - for (int ii = 0; ii <= domain_size; ++ii) - n_str += geom[ii].FastGetSolutionStepValue(IS_STRUCTURE); - - //if two walls are at the wall, we check if the third node is close to it or not by passing the alpha-shape - if (n_str == 3.0) - { - boost::numeric::ublas::bounded_matrix sort_coord = ZeroMatrix(4, 3); - int cnt = 1; - for (int i = 0; i < 4; ++i) - { - if (geom[i].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0) - { - sort_coord(0, 0) = geom[i].X(); - sort_coord(0, 1) = geom[i].Y(); - sort_coord(0, 2) = geom[i].Z(); - } - else - { - sort_coord(cnt, 0) = geom[i].X(); - sort_coord(cnt, 1) = geom[i].Y(); - sort_coord(cnt, 2) = geom[i].Z(); - cnt++; - } - } - array_1d vec1 = ZeroVector(3); - array_1d vec2 = ZeroVector(3); - array_1d vec3 = ZeroVector(3); - array_1d vec4 = ZeroVector(3); - - - vec1[0] = sort_coord(0, 0) - sort_coord(1, 0); - vec1[1] = sort_coord(0, 1) - sort_coord(1, 1); - vec1[2] = sort_coord(0, 2) - sort_coord(1, 2); - - vec2[0] = sort_coord(2, 0) - sort_coord(1, 0); - vec2[1] = sort_coord(2, 1) - sort_coord(1, 1); - vec2[2] = sort_coord(2, 2) - sort_coord(1, 2); - - vec3[0] = sort_coord(3, 0) - sort_coord(1, 0); - vec3[1] = sort_coord(3, 1) - sort_coord(1, 1); - vec3[2] = sort_coord(3, 2) - sort_coord(1, 2); - - //this last vectoris only needed to have all the edges of the base - vec4[0] = sort_coord(1, 0) - sort_coord(3, 0); - vec4[1] = sort_coord(1, 1) - sort_coord(3, 1); - vec4[2] = sort_coord(1, 2) - sort_coord(3, 2); - - //Control the hight of the thetraedral element - //Volume of the tethraedra - double vol = (vec2[0] * vec3[1] * vec1[2] - vec2[0] * vec3[2] * vec1[1] + - vec2[1] * vec3[2] * vec1[0] - vec2[1] * vec3[0] * vec1[2] + - vec2[2] * vec3[0] * vec1[1] - vec2[2] * vec3[1] * vec1[0])*0.1666666666667; - //Area of the basis - array_1d outer_prod = ZeroVector(3); - outer_prod[0] = vec2[1] * vec3[2] - vec2[2] * vec3[1]; - outer_prod[1] = vec2[2] * vec3[0] - vec2[0] * vec3[2]; - outer_prod[2] = vec2[0] * vec3[1] - vec2[1] * vec3[0]; - double area_base = norm_2(outer_prod); - area_base *= 0.5; - //height - if (area_base > 0.0000000000001) - vol /= area_base; - else - KRATOS_WATCH("Something strange: area of a wall triangular element --> zero"); - - double length_measure1 = norm_2(vec2); - double length_measure = norm_2(vec3); - double length_measure2 = norm_2(vec4); - - - if(length_measure1 < length_measure2) - { - if(length_measure1 < length_measure) - length_measure = length_measure1; - } - else - { - if(length_measure2 < length_measure) - length_measure = length_measure2; - } - - if (fabs(vol) < factor * length_measure) - { - for (int i = 0; i < 4; i++) - { - //if thats not the wall node, remove it - if (geom[i].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0) - { - geom[i].Set(TO_ERASE, true); - KRATOS_WATCH("NODE TOUCHING THE WALL - WILL BE ERASED!!!!") - } - } - } - }//interface elements - }//non_shell - }//all elements loop - }//domain_size==3 - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - - void MarkNodesTouchingInterface(ModelPart& ThisModelPart, int domain_size, double factor) - { - KRATOS_TRY; - - if (domain_size == 2) - { - - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - double n_intr = 0; - - //counting number on nodes at the Interface - Geometry< Node < 3 > >& geom = i->GetGeometry(); - n_intr = geom[0].FastGetSolutionStepValue(IS_INTERFACE); - n_intr += geom[1].FastGetSolutionStepValue(IS_INTERFACE); - n_intr += geom[2].FastGetSolutionStepValue(IS_INTERFACE); - //if two interfaces are at the interface, we check if the third node is close to it or not by passing the alpha-shape - if (n_intr == 2.0) - { - boost::numeric::ublas::bounded_matrix sort_coord = ZeroMatrix(3, 2); - int cnt = 1; - for (int i = 0; i < 3; ++i) - if (geom[i].FastGetSolutionStepValue(IS_INTERFACE) == 0.0) - { - sort_coord(0, 0) = geom[i].X(); - sort_coord(0, 1) = geom[i].Y(); - } - else - { - sort_coord(cnt, 0) = geom[i].X(); - sort_coord(cnt, 1) = geom[i].Y(); - cnt++; - } - - array_1d vec1 = ZeroVector(2); - array_1d vec2 = ZeroVector(2); - - vec1[0] = sort_coord(0, 0) - sort_coord(1, 0); - vec1[1] = sort_coord(0, 1) - sort_coord(1, 1); - - vec2[0] = sort_coord(2, 0) - sort_coord(1, 0); - vec2[1] = sort_coord(2, 1) - sort_coord(1, 1); - - double outer_prod = 0.0; - outer_prod = vec2[1] * vec1[0] - vec1[1] * vec2[0]; - - double length_measure = 0.0; - length_measure = vec2[0] * vec2[0] + vec2[1] * vec2[1]; - length_measure = sqrt(length_measure); - outer_prod /= length_measure; - - - double hnode2 = geom[0].FastGetSolutionStepValue(NODAL_H); - //hnode2*=hnode2; - - - //KRATOS_WATCH(fabs(outer_prod)); - // RATOS_WATCH(factor*length_measure); - - if (fabs(outer_prod) < factor * hnode2) - { - for (int i = 0; i < 3; i++) - { - //if thats not the wall node, remove it - if (geom[i].FastGetSolutionStepValue(IS_BOUNDARY) == 0.0 && geom[i].FastGetSolutionStepValue(IS_INTERFACE) == 0.0) - { - geom[i].Set(TO_ERASE, true); - //KRATOS_WATCH("NODE TOUCHING THE INTERFACE - WILL BE ERASED!!!!") - //KRATOS_WATCH(outer_prod) - } - } - } - } - - } - //not to delete interface nodes - /*for(ModelPart::NodeIterator ind = ThisModelPart.NodesBegin(); ind != ThisModelPart.NodesEnd(); ++ind) - { - if(ind->FastGetSolutionStepValue(IS_INTERFACE) ==1.0) - ind->Set(TO_ERASE, false); - - }*/ - - - - } - else if (domain_size == 3) - { - int elem_size = ThisModelPart.Elements().size(); - ModelPart::ElementIterator ElemBegin = ThisModelPart.ElementsBegin(); - ModelPart::ElementIterator ele; - - #pragma omp parallel for firstprivate(elem_size,ElemBegin),private(ele) - for (int kk = 0; kk < elem_size; kk++) - - { - ele = ElemBegin + kk; - - - int n_intr = 0; - - //counting number on nodes at the Interface - Geometry< Node < 3 > >& geom = ele->GetGeometry(); - - if (geom.size() == 4) - { - for (int ii = 0; ii <= domain_size; ++ii) - n_intr += int(geom[ii].FastGetSolutionStepValue(IS_INTERFACE)); - - //if three interfaces are at the interface, we check if the third node is close to it or not by passing the alpha-shape - if (n_intr == domain_size) - { - boost::numeric::ublas::bounded_matrix sort_coord = ZeroMatrix(4, 3); - int cnt = 1; - int non_interface_id = -1; - for (int j = 0; j <= domain_size; ++j) - { - if (geom[j].FastGetSolutionStepValue(IS_INTERFACE) == 0.0) - { - sort_coord(0, 0) = geom[j].X(); - sort_coord(0, 1) = geom[j].Y(); - sort_coord(0, 2) = geom[j].Z(); - non_interface_id = j; - } - else - { - sort_coord(cnt, 0) = geom[j].X(); - sort_coord(cnt, 1) = geom[j].Y(); - sort_coord(cnt, 2) = geom[j].Z(); - cnt++; - } - } - array_1d outplane = ZeroVector(3); - array_1d inplane1 = ZeroVector(3); - array_1d inplane2 = ZeroVector(3); - - outplane[0] = sort_coord(0, 0) - sort_coord(1, 0); - outplane[1] = sort_coord(0, 1) - sort_coord(1, 1); - outplane[2] = sort_coord(0, 2) - sort_coord(1, 2); - - inplane1[0] = sort_coord(2, 0) - sort_coord(1, 0); - inplane1[1] = sort_coord(2, 1) - sort_coord(1, 1); - inplane1[2] = sort_coord(2, 2) - sort_coord(1, 2); - - inplane2[0] = sort_coord(3, 0) - sort_coord(1, 0); - inplane2[1] = sort_coord(3, 1) - sort_coord(1, 1); - inplane2[2] = sort_coord(3, 2) - sort_coord(1, 2); - - //calculate normal to the surface - array_1d outerprod = ZeroVector(3); - //boost::numeric::ublas::bounded_matrix outerprod = ZeroMatrix(1, 3); - outerprod[0] = inplane1[1] * inplane2[2] - inplane1[2] * inplane2[1]; - outerprod[1] = inplane1[2] * inplane2[0] - inplane1[0] * inplane2[2]; - outerprod[2] = inplane1[0] * inplane2[1] - inplane1[1] * inplane2[0]; - - //outerprod = outer_prod(inplane1,inplane2); - - - double len = inner_prod(outerprod, outerprod); - len /= sqrt(len); - // double len = outerprod(0,0)*outerprod(0,0) + outerprod(1,0)*outerprod(1,0) + outerprod(2,0)*outerprod(2,0); - outerprod /= len; - - //calc distance to surface - double dist_to_surf = 0.0; - dist_to_surf = inner_prod(outerprod, outplane); - // dist_to_surf = outerprod(0,0)*outplane(0)+ outerprod(1,0)*outplane(1)+outerprod(2,0)*outplane(2); - - //get H - double hnode2 = (ThisModelPart.GetProperties(0))[THICKNESS]; - - // double hnode2 = geom[non_interface_id].FastGetSolutionStepValue(NODAL_H); - // hnode2*=hnode2; - - //mark node to delete - if (fabs(dist_to_surf) < factor * hnode2) - { - geom[non_interface_id].SetLock(); - geom[non_interface_id].Set(TO_ERASE, true); - - geom[non_interface_id].UnSetLock(); - - - // KRATOS_WATCH("NODE TOUCHING THE SURFACE - WILL BE ERASED!!!!") - // KRATOS_WATCH(dist_to_surf) - - } - - }//interface elemenets - }//non_shell - }//all elements loop - }//domain_size==3 - KRATOS_CATCH("") - } - //********************************************************************************************** - //********************************************************************************************** - - void InterfaceDetecting(ModelPart& ThisModelPart, int domain_size, double factor) - { - KRATOS_TRY; - - for (ModelPart::NodeIterator ind = ThisModelPart.NodesBegin(); ind != ThisModelPart.NodesEnd(); ++ind) - ind->FastGetSolutionStepValue(IS_INTERFACE) = 0.0; - - - - for (ModelPart::ElementsContainerType::iterator elem = ThisModelPart.ElementsBegin(); - elem != ThisModelPart.ElementsEnd(); elem++) - { - - if (elem->GetValue(IS_WATER_ELEMENT) == 0) - { - - WeakPointerVector< Element >& neighbor_els = elem->GetValue(NEIGHBOUR_ELEMENTS); - Geometry< Node < 3 > >& geom = elem->GetGeometry(); - - for (int ii = 0; ii < (domain_size + 1); ++ii) - { - - if (neighbor_els[ii].GetValue(IS_WATER_ELEMENT) == 1 && neighbor_els[ii].Id() != elem->Id()) - { - - if (ii == 0) // 1,2 and/or 3 - { - if (geom[1].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0 && geom[2].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0) - { - - - geom[1].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - geom[2].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - if (domain_size == 3) - geom[3].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - - } - } - if (ii == 1) // 0,2 and/or 3 - { - if (geom[0].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0 && geom[2].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0) - { - - - geom[0].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - geom[2].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - if (domain_size == 3) - geom[3].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - - } - } - if (ii == 2) // 0,1 and/or 3 - { - if (geom[0].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0 && geom[1].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0) - { - - geom[0].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - geom[1].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - if (domain_size == 3) - geom[3].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - - } - } - if (ii == 3) // 0,1 and/or 2 - { - if (geom[0].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0 && geom[1].FastGetSolutionStepValue(IS_STRUCTURE) == 0.0) - { - - geom[0].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - geom[1].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - if (domain_size == 3) - geom[2].FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - - } - } - - } - } - - } - } - /* for(ModelPart::NodeIterator ind = ThisModelPart.NodesBegin(); ind != ThisModelPart.NodesEnd(); ++ind) - ind->FastGetSolutionStepValue(IS_INTERFACE) = 0.0; - - for(ModelPart::NodeIterator ind = ThisModelPart.NodesBegin(); ind != ThisModelPart.NodesEnd(); ++ind) - { - if(ind->FastGetSolutionStepValue(IS_WATER) == 0.0 && ind->FastGetSolutionStepValue(IS_STRUCTURE) !=1.0) - { - //to loop over just one kind of fluid (the one that has boundary node at the begining) - WeakPointerVector< Node<3> >& neighb = ind->GetValue(NEIGHBOUR_NODES); - int other_kind = 0; - - for( WeakPointerVector< Node<3> >::iterator ngh_ind = neighb.begin(); ngh_ind!=neighb.end(); ngh_ind++) - { - if(ngh_ind->FastGetSolutionStepValue(IS_WATER) ==1.0 && ngh_ind->FastGetSolutionStepValue(IS_STRUCTURE) !=1.0) - other_kind++; - } - - if(other_kind) - ind->FastGetSolutionStepValue(IS_INTERFACE) = 1.0; - } - - }*/ - //KRATOS_WATCH("NEw interface nodes are detected"); - - //free elements having three interface nodes - /*for(ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i!=ThisModelPart.ElementsEnd(); i++) - { - Geometry< Node<3> >& geom = i->GetGeometry(); - double n_intr=0; - for(int ii=0;ii<3;++ii) - if(geom[ii].FastGetSolutionStepValue(IS_INTERFACE) == 1.0) - n_intr++; - - if(n_intr == 3.0) - for(int ii=0;ii<3;++ii) - geom[ii].FastGetSolutionStepValue(IS_INTERFACE) = 0.0; - - }*/ - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - - void ChangeWallWaterFlag(ModelPart& ThisModelPart, int domain_size) - { - KRATOS_TRY; - for (ModelPart::NodeIterator ind = ThisModelPart.NodesBegin(); ind != ThisModelPart.NodesEnd(); ++ind) - { - if (ind->FastGetSolutionStepValue(IS_STRUCTURE) == 1.0) - { - double current_flag = ind->FastGetSolutionStepValue(IS_WATER); - double opposit_flag; - if (current_flag == 1.0) - opposit_flag = 0.0; - else - opposit_flag = 1.0; - int same_flag = 0; - - WeakPointerVector< Node < 3 > >& neighb = ind->GetValue(NEIGHBOUR_NODES); - - for (WeakPointerVector< Node < 3 > >::iterator ngh_ind = neighb.begin(); ngh_ind != neighb.end(); ngh_ind++) - { - if (ngh_ind->FastGetSolutionStepValue(IS_STRUCTURE) != 1.0 && ngh_ind->FastGetSolutionStepValue(IS_INTERFACE) != 1.0) - { - double ngh_flag = ngh_ind->FastGetSolutionStepValue(IS_WATER); - if (current_flag == ngh_flag) - same_flag++; - else - opposit_flag = ngh_flag; - } - } - if (!same_flag) - ind->FastGetSolutionStepValue(IS_WATER) = opposit_flag; - } - } - KRATOS_CATCH("") - } - //********************************************************************************************** - //********************************************************************************************** - - void ChangeInterfaceWaterFlag(ModelPart& ThisModelPart, int domain_size) - { - KRATOS_TRY; - for (ModelPart::NodeIterator ind = ThisModelPart.NodesBegin(); ind != ThisModelPart.NodesEnd(); ++ind) - { - if (ind->FastGetSolutionStepValue(IS_INTERFACE) == 1.0) - { - double current_flag = ind->FastGetSolutionStepValue(IS_WATER); - double opposit_flag; - if (current_flag == 1.0) - opposit_flag = 0.0; - else - opposit_flag = 1.0; - int same_flag = 0; - - WeakPointerVector< Node < 3 > >& neighb = ind->GetValue(NEIGHBOUR_NODES); - - for (WeakPointerVector< Node < 3 > >::iterator ngh_ind = neighb.begin(); ngh_ind != neighb.end(); ngh_ind++) - { - if (ngh_ind->FastGetSolutionStepValue(IS_STRUCTURE) != 1.0 && ngh_ind->FastGetSolutionStepValue(IS_INTERFACE) != 1.0) - { - double ngh_flag = ngh_ind->FastGetSolutionStepValue(IS_WATER); - if (current_flag == ngh_flag) - same_flag++; - else - opposit_flag = ngh_flag; - } - } - if (!same_flag) - ind->FastGetSolutionStepValue(IS_WATER) = opposit_flag; - } - } - KRATOS_CATCH("") - } - //********************************************************************************************** - //********************************************************************************************** - - void AssignNearBoundaryH(ModelPart& ThisModelPart, double factor) - { - KRATOS_TRY; - KRATOS_WATCH("NNNNNNNNNNNNNNearBoundaryHHHHHHHHHHHHHHHH"); - for (ModelPart::NodeIterator ind = ThisModelPart.NodesBegin(); ind != ThisModelPart.NodesEnd(); ++ind) - { - const double current_flag = ind->FastGetSolutionStepValue(IS_WATER); - - double same_flag = 1.0; - double opposit_flag = 0.0; - - WeakPointerVector< Node < 3 > >& neighb = ind->GetValue(NEIGHBOUR_NODES); - for (WeakPointerVector< Node < 3 > >::iterator ngh_ind = neighb.begin(); ngh_ind != neighb.end(); ngh_ind++) - { - const double ngh_flag = ngh_ind->FastGetSolutionStepValue(IS_WATER); - if (current_flag == ngh_flag) - same_flag++; - else - opposit_flag++; - } - - if (opposit_flag / same_flag > 1.0) - { - double current_H = ind->FastGetSolutionStepValue(NODAL_H); - double new_H = current_H / factor; - - ind->FastGetSolutionStepValue(NODAL_H) = new_H; - /* for( WeakPointerVector< Node<3> >::iterator ngh_ind = neighb.begin(); ngh_ind!=neighb.end(); ngh_ind++) - ngh_ind->FastGetSolutionStepValue(NODAL_H)=new_H;*/ - - - } - } - KRATOS_WATCH("NNNNNNNNNNNNNNearBoundaryHHHHHHHHHHHHHHHH~~~~~~~~~~~~~EXIT"); - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - - void MoveNodes(ModelPart& ThisModelPart) - { - KRATOS_TRY - - for (ModelPart::NodeIterator ind = ThisModelPart.NodesBegin(); ind != ThisModelPart.NodesEnd(); ++ind) - { - (ind)->X() = (ind)->X0() + ind->GetSolutionStepValue(DISPLACEMENT_X); - (ind)->Y() = (ind)->Y0() + ind->GetSolutionStepValue(DISPLACEMENT_Y); - (ind)->Z() = (ind)->Z0() + ind->GetSolutionStepValue(DISPLACEMENT_Z); - } - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - - void AssignMeshVelocity(ModelPart& ThisModelPart) - { - KRATOS_TRY - - for (ModelPart::NodeIterator ind = ThisModelPart.NodesBegin(); ind != ThisModelPart.NodesEnd(); ++ind) - { - - (ind)->FastGetSolutionStepValue(MESH_VELOCITY_X) = (ind)->FastGetSolutionStepValue(VELOCITY_X); - (ind)->FastGetSolutionStepValue(MESH_VELOCITY_Y) = (ind)->FastGetSolutionStepValue(VELOCITY_Y); - (ind)->FastGetSolutionStepValue(MESH_VELOCITY_Z) = (ind)->FastGetSolutionStepValue(VELOCITY_Z); - - } - KRATOS_CATCH("") - } - - //********************************************************************************************** - //********************************************************************************************** - //ATTENTION:: returns a negative volume if inverted elements appear - - double CalculateVolume(ModelPart& ThisModelPart, int domain_size) - { - KRATOS_TRY; - - bool inverted_elements = false; - //auxiliary vectors - double Atot = 0.00; - if (domain_size == 2) - { - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node < 3 > >& geom = i->GetGeometry(); - double Ael = 0.0; - if (geom.size() == 3) - { - Ael = GeometryUtils::CalculateVolume2D(geom); - Atot += Ael; - } - if (Ael < 0) inverted_elements = true; - } - } - else if (domain_size == 3) - { - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node < 3 > >& geom = i->GetGeometry(); - - double Ael = 0.0; - if (geom.size() == 4) - { - Ael = GeometryUtils::CalculateVolume3D(geom); - Atot += Ael; - } - if (Ael < 0) inverted_elements = true; - } - } - - //set to negative the volume if inverted elements appear - if (inverted_elements == true) - Atot = -Atot; - - //return the total area - return Atot; - KRATOS_CATCH(""); - } - //********************************************************************************************** - bool CheckInvertedElements(ModelPart& ThisModelPart, int domain_size) - { - KRATOS_TRY; - - bool inverted_elements = false; - //auxiliary vectors - double Atot = 0.00; - if (domain_size == 2) - { - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node < 3 > >& geom = i->GetGeometry(); - double Ael = 0.0; - if (geom.size() == 3) - { - Ael = GeometryUtils::CalculateVolume2D(geom); - Atot += Ael; - } - if (Ael < 0) inverted_elements = true; - } - } - else if (domain_size == 3) - { - for (ModelPart::ElementsContainerType::iterator i = ThisModelPart.ElementsBegin(); - i != ThisModelPart.ElementsEnd(); i++) - { - //calculating shape functions values - Geometry< Node < 3 > >& geom = i->GetGeometry(); - - double Ael = 0.0; - if (geom.size() == 4) - { - Ael = GeometryUtils::CalculateVolume3D(geom); - Atot += Ael; - } - if (Ael < 0) inverted_elements = true; - } - } - - //return the bool inverted elements - return inverted_elements; - KRATOS_CATCH(""); - } - - //********************************************************************************************** - - void ColourAirWaterElement(ModelPart& ThisModelPart, int domain_size) - { - KRATOS_TRY; - KRATOS_WATCH("INSSSSSSSSSIDE COLOUR"); - ModelPart::ElementsContainerType::iterator elem_bg = ThisModelPart.ElementsBegin(); - const unsigned int n_elems = ThisModelPart.Elements().size(); - - //#pragma omp parallel for firstprivate(n_elems, elem_bg) - for (unsigned int jj = 0; jj < n_elems; ++jj) - { - ModelPart::ElementsContainerType::iterator elem = elem_bg + jj; - - Geometry< Node < 3 > >& geom = elem->GetGeometry(); - int same_colour = 0; - - //count air flag - for (int ii = 0; ii <= domain_size; ++ii) - if (geom[ii].FastGetSolutionStepValue(IS_WATER) == 0.0) - same_colour++; - - if (same_colour == (domain_size + 1)) - { - elem->GetValue(IS_WATER_ELEMENT) = 0.0; - - } - else - { - elem->GetValue(IS_WATER_ELEMENT) = 1.0; - - - } - - } - //#pragma omp barrier - //detecting interface nodes - - //PfemUtils::InterfaceDetecting(ThisModelPart, domain_size, 5.0); - - - - - /* //chack for apex elements of all interface - for(ModelPart::ElementsContainerType::iterator elem = ThisModelPart.ElementsBegin(); - elem!=ThisModelPart.ElementsEnd(); elem++) - { - if(elem->GetValue(IS_WATER_ELEMENT) == 0.0) - { - Geometry< Node<3> >& geom = elem->GetGeometry(); - int is_interface = 0; - - for(int ii= 0; ii<= domain_size; ++ii) - if(geom[ii].FastGetSolutionStepValue(IS_INTERFACE) == 1.0) - is_interface++; - - if(is_interface == (domain_size + 1)) - { - WeakPointerVector< Element >& neighbor_els = elem->GetValue(NEIGHBOUR_ELEMENTS); - - double ref_elem_flag = 0.0; //interface is always 0 - double water_neghbs = 0; - - for(int ii=0; ii<(domain_size+1); ++ii) - { - - if(neighbor_els[ii].GetValue(IS_WATER_ELEMENT) != ref_elem_flag && neighbor_els[ii].Id() != elem->Id()) - water_neghbs++; - } - - if(water_neghbs == 1.0) //so change the flag to WATER - { - elem->GetValue(IS_WATER_ELEMENT) = 1.0; - KRATOS_WATCH("CHANGE CHANGE CHANGE CHANGE CHANGE CHANGE"); - KRATOS_WATCH(elem->Id()); - } - } - } - }*/ - - KRATOS_CATCH(""); - } - - //********************************************************************************************** - //********************************************************************************************** - - void ReduceTimeStep(ModelPart& ThisModelPart) - { - KRATOS_TRY; - - double dt = ThisModelPart.GetProcessInfo()[DELTA_TIME]; - double time = ThisModelPart.GetProcessInfo()[TIME]; - - ThisModelPart.GetProcessInfo()[TIME] = time - dt * 0.5; - ThisModelPart.GetProcessInfo()[DELTA_TIME] = dt * 0.5; - - KRATOS_CATCH(""); - } - //********************************************************************************************** - //********************************************************************************************** - - double ExplicitDeltaT(double CFL, double min_dt, double max_dt, ModelPart& ThisModelPart) - { - KRATOS_TRY - - int NumThreads = OpenMPUtils::GetNumThreads(); - std::vector< double > Threads_dt(NumThreads, 10.0); - - ModelPart::ElementsContainerType::iterator elem_bg = ThisModelPart.ElementsBegin(); - int n_elems = ThisModelPart.Elements().size(); - - #pragma omp parallel for firstprivate(n_elems, elem_bg) - for (int ii = 0; ii < n_elems; ++ii) - { - //calculate min_dt - ModelPart::ElementsContainerType::iterator elem = elem_bg + ii; - - double calc_dt = 1.0; - elem->Calculate(DELTA_TIME, calc_dt, ThisModelPart.GetProcessInfo()); - - int k = OpenMPUtils::ThisThread(); - if (calc_dt < Threads_dt[k]) - Threads_dt[k] = calc_dt; - - } - #pragma omp barrier - - //KRATOS_WATCH(omp_get_thread_num()); - KRATOS_WATCH(NumThreads); - - double DT = max_dt; - for (int kk = 0; kk < NumThreads; ++kk) - if (Threads_dt[kk] < DT) - DT = Threads_dt[kk]; - - - - if (DT < min_dt) DT = min_dt; - - // double DT = 0.00000001; - DT *= CFL; - ThisModelPart.GetProcessInfo()[DELTA_TIME] = DT; - KRATOS_WATCH("ExplicitDeltaT"); - KRATOS_WATCH(DT); - return DT; - - - /* - - double& DeltaTime = ThisModelPart.GetProcessInfo()[DELTA_TIME]; - double DT = 10.0; - - ModelPart::ElementsContainerType::iterator elem_bg = ThisModelPart.ElementsBegin(); - unsigned int n_elems = ThisModelPart.Elements().size(); - - #pragma omp parallel for firstprivate(n_elems, elem_bg) - for(unsigned int ii=0; iiCalculate(DELTA_TIME, calc_dt, ThisModelPart.GetProcessInfo()); - - if(calc_dt < DT) - { - #pragma omp critical - DT = CFL*calc_dt; - - } - - } - - KRATOS_WATCH("@@@@@@@@@@@@@@@@@@@@@@@@@@ BEFORE @@@@@@@@@@"); - KRATOS_WATCH(DeltaTime); - if(DT> max_dt) - DT = max_dt; - else if(DT < min_dt) - DT = min_dt; - KRATOS_WATCH("@@@@@@@@@@@@@@@@@@@@@@@@@@ DELTA T EXPLICIT@@@@@@@@@@"); - DeltaTime = DT; - KRATOS_WATCH(DeltaTime); - - - return DeltaTime;*/ - KRATOS_CATCH(""); - } - - -private: - - //aux vars - static boost::numeric::ublas::bounded_matrix msJ; //local jacobian - static boost::numeric::ublas::bounded_matrix msJinv; //inverse jacobian - static array_1d msc; //center pos - static array_1d ms_rhs; //center pos - - - -}; - - -} // namespace Kratos. - -#endif // KRATOS_PFEM_UTILITIES_INCLUDED defined - - diff --git a/applications/PFEMapplication/custom_utilities/twofluid_gid_io.h b/applications/PFEMapplication/custom_utilities/twofluid_gid_io.h deleted file mode 100644 index 4d96a2db4939..000000000000 --- a/applications/PFEMapplication/custom_utilities/twofluid_gid_io.h +++ /dev/null @@ -1,596 +0,0 @@ -/* -============================================================================== -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNER. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - -// -// Project Name: Kratos -// Last Modified by: $Author: kazem $ -// Date: $Date: 2009-01-15 14:50:24 $ -// Revision: $Revision: 1.8 $ -// -// - -#if !defined(KRATOS_TWOFLUID_GID_IO_BASE_H_INCLUDED) -#define KRATOS_TWOFLUID_GID_IO_BASE_H_INCLUDED - -// System includes -#include -#include -#include -#include -#include - - -// Project includes -#include "includes/define.h" -//#include "includes/datafile_io.h" -#include "includes/gid_io.h" - -namespace Kratos -{ -/** - * Type definitions - */ -typedef ModelPart::ElementsContainerType ElementsArrayType; -typedef ModelPart::NodesContainerType NodesArrayType; -typedef ModelPart::ConditionsContainerType ConditionsArrayType; -typedef GeometryData::IntegrationMethod IntegrationMethodType; -typedef GeometryData::KratosGeometryFamily KratosGeometryFamily; - -/** - * Auxiliary class to store gauss point containers and perform result printing - * on gauss points - */ -class TwoFluidGidGaussPointsContainer -{ -public: - ///Constructor - TwoFluidGidGaussPointsContainer( const char* gp_title, KratosGeometryFamily geometryFamily, - GiD_ElementType gid_element_type, - unsigned int number_of_integration_points, - std::vector index_container ) - :mGPTitle(gp_title),mKratosElementFamily(geometryFamily), - mGidElementFamily(gid_element_type), mSize(number_of_integration_points), - mIndexContainer(index_container) {} - - bool AddElement( const ModelPart::ElementsContainerType::iterator pElemIt ) - { - KRATOS_TRY - if( pElemIt->GetGeometry().GetGeometryFamily() == mKratosElementFamily - && pElemIt->GetGeometry().IntegrationPoints( - pElemIt->GetIntegrationMethod() ).size() == mSize ) - { - mMeshElements.push_back( *(pElemIt.base() ) ); - return true; - } - else return false; - KRATOS_CATCH("") - } - - bool AddCondition( const ModelPart::ConditionsContainerType::iterator pCondIt ) - { - KRATOS_TRY - if( pCondIt->GetGeometry().GetGeometryFamily() == mKratosElementFamily - && pCondIt->GetGeometry().IntegrationPoints().size() == mSize ) - { - mMeshConditions.push_back( *(pCondIt.base() ) ); - return true; - } - else return false; - KRATOS_CATCH("") - } - - void PrintResults( GiD_FILE ResultFile, Variable rVariable, ModelPart& r_model_part, - double SolutionTag, unsigned int value_index = 0 ) - { - if( mMeshElements.size() != 0 || mMeshConditions.size() != 0 ) - { - WriteGaussPoints(ResultFile); - GiD_fBeginResult( ResultFile, (char*)(rVariable.Name()).c_str(), "Kratos", SolutionTag, - GiD_Scalar, GiD_OnGaussPoints, mGPTitle, NULL, 0, NULL ); - std::vector ValuesOnIntPoint(mSize); - if( mMeshElements.size() != 0 ) - { - for( ModelPart::ElementsContainerType::iterator it = mMeshElements.begin(); - it != mMeshElements.end(); it++ ) - { - it->GetValueOnIntegrationPoints( rVariable, ValuesOnIntPoint, - r_model_part.GetProcessInfo() ); - for(unsigned int i=0; iId(), ValuesOnIntPoint[index] ); - } - } - } - if( mMeshConditions.size() != 0 ) - { - for( ModelPart::ConditionsContainerType::iterator it = mMeshConditions.begin(); - it != mMeshConditions.end(); it++ ) - { - it->GetValueOnIntegrationPoints( rVariable, ValuesOnIntPoint, - r_model_part.GetProcessInfo() ); - for(unsigned int i=0; iId(), ValuesOnIntPoint[index] ); - } - } - } - GiD_fEndResult(ResultFile); - } - } - - void PrintResults( GiD_FILE ResultFile, Variable rVariable, ModelPart& r_model_part, - double SolutionTag, unsigned int value_index = 0 ) - { - if( mMeshElements.size() != 0 || mMeshConditions.size() != 0 ) - { - WriteGaussPoints(ResultFile ); - GiD_fBeginResult( ResultFile, (char *)(rVariable.Name()).c_str(), "Kratos", SolutionTag, - GiD_Vector, GiD_OnGaussPoints, mGPTitle, NULL, 0, NULL ); - std::vector ValuesOnIntPoint(mSize); - if( mMeshElements.size() != 0 ) - { - for( ModelPart::ElementsContainerType::iterator it = mMeshElements.begin(); - it != mMeshElements.end(); ++it ) - { - it->GetValueOnIntegrationPoints( rVariable, ValuesOnIntPoint, - r_model_part.GetProcessInfo() ); - for(unsigned int i=0; iId(), ValuesOnIntPoint[index][0], - ValuesOnIntPoint[index][1], ValuesOnIntPoint[index][2] ); - } - } - } - if( mMeshConditions.size() != 0 ) - { - for( ModelPart::ConditionsContainerType::iterator it = mMeshConditions.begin(); - it != mMeshConditions.end(); it++ ) - { - it->GetValueOnIntegrationPoints( rVariable, ValuesOnIntPoint, - r_model_part.GetProcessInfo() ); - for(unsigned int i=0; iId(), ValuesOnIntPoint[index][0], - ValuesOnIntPoint[index][1], ValuesOnIntPoint[index][2] ); - } - } - } - GiD_fEndResult(ResultFile); - } - } - - void PrintResults( GiD_FILE ResultFile, Variable rVariable, ModelPart& r_model_part, - double SolutionTag, unsigned int value_index = 0 ) - { - if( mMeshElements.size() != 0 || mMeshConditions.size() != 0 ) - { - WriteGaussPoints(ResultFile); - GiD_fBeginResult(ResultFile, (char *)(rVariable.Name()).c_str(), "Kratos", SolutionTag, - GiD_Matrix, GiD_OnGaussPoints, mGPTitle, NULL, 0, NULL ); - std::vector ValuesOnIntPoint(mSize); - if( mMeshElements.size() != 0 ) - { - for( ModelPart::ElementsContainerType::iterator it = mMeshElements.begin(); - it != mMeshElements.end(); ++it ) - { - it->GetValueOnIntegrationPoints( rVariable, ValuesOnIntPoint, - r_model_part.GetProcessInfo() ); - for(unsigned int i=0; iId(), ValuesOnIntPoint[index](0,0), - ValuesOnIntPoint[index](1,1), ValuesOnIntPoint[index](2,2), - ValuesOnIntPoint[index](0,1), ValuesOnIntPoint[index](1,2), - ValuesOnIntPoint[index](0,2) ); - if(ValuesOnIntPoint[index].size1() ==1 - && ValuesOnIntPoint[index].size2() ==6) - GiD_fWrite3DMatrix( ResultFile, it->Id(), ValuesOnIntPoint[index](0,0), - ValuesOnIntPoint[index](0,1), ValuesOnIntPoint[index](0,2), - ValuesOnIntPoint[index](0,3), ValuesOnIntPoint[index](0,4), - ValuesOnIntPoint[index](0,5) ); - } - } - } - if( mMeshConditions.size() != 0 ) - { - for( ModelPart::ConditionsContainerType::iterator it = mMeshConditions.begin(); - it != mMeshConditions.end(); it++ ) - { - it->GetValueOnIntegrationPoints( rVariable, ValuesOnIntPoint, - r_model_part.GetProcessInfo() ); - for(unsigned int i=0; iId(), ValuesOnIntPoint[index](0,0), - ValuesOnIntPoint[index](1,1), ValuesOnIntPoint[index](2,2), - ValuesOnIntPoint[index](0,1), ValuesOnIntPoint[index](1,2), - ValuesOnIntPoint[index](0,2) ); - if(ValuesOnIntPoint[index].size1() ==1 - && ValuesOnIntPoint[index].size2() ==6) - GiD_fWrite3DMatrix( ResultFile, it->Id(), ValuesOnIntPoint[index](0,0), - ValuesOnIntPoint[index](0,1), ValuesOnIntPoint[index](0,2), - ValuesOnIntPoint[index](0,3), ValuesOnIntPoint[index](0,4), - ValuesOnIntPoint[index](0,5) ); - } - } - } - GiD_fEndResult(ResultFile); - } - } - - void PrintResults( GiD_FILE ResultFile, Variable > rVariable, ModelPart& r_model_part, - double SolutionTag, int value_index = 0 ) - { - } - - void PrintResults( GiD_FILE ResultFile, Variable rVariable, ModelPart& r_model_part, - double SolutionTag, int value_index = 0 ) - { - } - - void Reset() - { - mMeshElements.clear(); - mMeshConditions.clear(); - } - -public: - - void WriteGaussPoints(GiD_FILE ResultFile) - { - if( mMeshElements.size() != 0 || mMeshConditions.size() != 0 ) - { - //setting up gauss points - if( mGidElementFamily == GiD_Tetrahedra && mSize == 5 ) - { - GiD_fBeginGaussPoint( ResultFile, mGPTitle, GiD_Tetrahedra, NULL, 4, 0, 0 ); - GiD_fWriteGaussPoint3D( ResultFile, 1.0/6.0, 1.0/6.0, 1.0/6.0 ); - GiD_fWriteGaussPoint3D( ResultFile, 1.0/2.0, 1.0/6.0, 1.0/6.0 ); - GiD_fWriteGaussPoint3D( ResultFile, 1.0/6.0, 1.0/2.0, 1.0/6.0 ); - GiD_fWriteGaussPoint3D( ResultFile, 1.0/6.0, 1.0/6.0, 1.0/2.0 ); - GiD_fEndGaussPoint(ResultFile); - } - else if( mGidElementFamily == GiD_Tetrahedra && mSize == 10 ) - { - GiD_fBeginGaussPoint(ResultFile, "tet10_element_gp", GiD_Tetrahedra, NULL, 4, 0, 0); - GiD_fWriteGaussPoint3D(ResultFile, 1.0/14.0, 1.0/14.0, 1.0/14.0 ); - GiD_fWriteGaussPoint3D(ResultFile, 11.0/14.0, 1.0/14.0, 1.0/14.0 ); - GiD_fWriteGaussPoint3D(ResultFile, 1.0/14.0, 11.0/14.0, 1.0/14.0 ); - GiD_fWriteGaussPoint3D(ResultFile, 1.0/14.0, 1.0/14.0, 11.0/14.0 ); - GiD_fEndGaussPoint(ResultFile); - } - else - { - GiD_fBeginGaussPoint(ResultFile, mGPTitle, mGidElementFamily, NULL, - mSize, 0, 1); - GiD_fEndGaussPoint(ResultFile); - } - } - } -protected: - ///member variables - - const char* mGPTitle; - KratosGeometryFamily mKratosElementFamily; - GiD_ElementType mGidElementFamily; - unsigned int mSize; - std::vector mIndexContainer; - ModelPart::ElementsContainerType mMeshElements; - ModelPart::ConditionsContainerType mMeshConditions; -};//class TwoFluidGidGaussPointsContainer - -/** - * Auxiliary class to store meshes of different element types and to - * write these meshes to an output file - */ -class TwoFluidGidMeshContainer -{ -public: - ///Constructor - TwoFluidGidMeshContainer( GeometryData::KratosGeometryType geometryType, - GiD_ElementType elementType, const char* mesh_title ) - :mGeometryType(geometryType), mGidElementType(elementType), mMeshTitle(mesh_title) {} - - bool AddElement( const ModelPart::ElementsContainerType::iterator pElemIt ) - { - KRATOS_TRY - if( pElemIt->GetGeometry().GetGeometryType() == mGeometryType ) - { - mMeshElements.push_back( *(pElemIt.base() ) ); - Geometry >&geom = pElemIt->GetGeometry(); - for( Element::GeometryType::iterator it = geom.begin(); it != geom.end(); it++) - { - mMeshNodes.push_back( *(it.base() ) ); - } - return true; - } - else - return false; - KRATOS_CATCH("") - } - - bool AddCondition(const ModelPart::ConditionsContainerType::iterator pCondIt) - { - KRATOS_TRY - if( pCondIt->GetGeometry().GetGeometryType() == mGeometryType ) - { - mMeshConditions.push_back( *(pCondIt.base() ) ); - Geometry >&geom = pCondIt->GetGeometry(); - for( Condition::GeometryType::iterator it = geom.begin(); it != geom.end(); it++) - { - mMeshNodes.push_back( *(it.base() ) ); - } - return true; - } - else - return false; - KRATOS_CATCH("") - } - - void FinalizeMeshCreation() - { - if( mMeshElements.size() != 0 ) - { - mMeshNodes.Unique(); - } - } - - void WriteMesh(GiD_FILE MeshFile, bool deformed) - { - KRATOS_TRY - if( mMeshElements.size() != 0 ) - { - if( mMeshElements.begin()->GetGeometry().WorkingSpaceDimension() == 2 ) - { - std::cout << "writing a 2D mesh" << std::endl; - GiD_fBeginMesh(MeshFile, "Volume mesh", GiD_2D, mGidElementType, - mMeshElements.begin()->GetGeometry().size() ); - } - else if( mMeshElements.begin()->GetGeometry().WorkingSpaceDimension() == 3 ) - { - std::cout << "writing a 3D two_fluid mesh" << std::endl; - GiD_fBeginMesh(MeshFile, "Volume mesh", GiD_3D, mGidElementType, - mMeshElements.begin()->GetGeometry().size() ); - } - else - KRATOS_THROW_ERROR(std::logic_error,"check working space dimension of model",""); - //printing nodes - GiD_fBeginCoordinates(MeshFile ); - for( ModelPart::NodesContainerType::iterator it = mMeshNodes.begin(); - it != mMeshNodes.end(); ++it ) - { - if( deformed ) - GiD_fWriteCoordinates(MeshFile, (it)->Id(), (it)->X(), - (it)->Y(), (it)->Z()); - else - GiD_fWriteCoordinates(MeshFile, (it)->Id(), (it)->X0(), - (it)->Y0(), (it)->Z0()); - } - GiD_fEndCoordinates(MeshFile ); - //printing elements - GiD_fBeginElements(MeshFile ); - int* nodes_id = new int[mMeshElements.begin()->GetGeometry().size()+1]; - for( ModelPart::ElementsContainerType::iterator it = mMeshElements.begin(); - it != mMeshElements.end(); ++it ) - { - for( unsigned int i=0; i<(it)->GetGeometry().size(); i++ ) - nodes_id[i] = (it)->GetGeometry()[i].Id(); - - //setting the color for either fluid or Air or contact element - int n_water=0; - //int n_air=0; - //int n_inter=0; - int color=13; - for ( unsigned int i=0; i<(it)->GetGeometry().size(); i++ ) - { - n_water += int(it->GetGeometry()[i].FastGetSolutionStepValue(IS_WATER)); - //n_str+= int(it->GetGeometry()[i].FastGetSolutionStepValue(IS_STRUCTURE)); - //n_interf+= int(it->GetGeometry()[i].FastGetSolutionStepValue(IS_INTERFACE)); - } - if (n_water == 4)// && n_str!= (it)->GetGeometry().size() && n_interf!=30) - { - color = 4; - } - if (n_water == 0) - { - color = 14; - } - else - { - color = 5; - } - /*if (n_str==int((it)->GetGeometry().size()))// && n_fl!=(it)->GetGeometry().size()) - { - color=14; - } - if (n_interf==40) - { - color=5; - }*/ - - - nodes_id[(it)->GetGeometry().size()]= color; - - GiD_fWriteElementMat(MeshFile, (it)->Id(), nodes_id); - } - delete [] nodes_id; - GiD_fEndElements(MeshFile ); - GiD_fEndMesh(MeshFile ); - } - if( mMeshConditions.size() != 0 ) - { - KRATOS_WATCH( mMeshConditions.begin()->GetGeometry().WorkingSpaceDimension() ) - - if( mMeshConditions.begin()->GetGeometry().WorkingSpaceDimension() == 3 ) - { - std::cout << "writing a 3D mesh of the faces" << std::endl; - GiD_fBeginMesh(MeshFile, "Surface Structure Mesh", GiD_3D, GiD_Triangle, 3); - } - else - KRATOS_THROW_ERROR(std::logic_error,"Check your space dimensions",""); - //printing nodes - GiD_fBeginCoordinates(MeshFile ); - - GiD_fEndCoordinates(MeshFile ); - //printing elements - GiD_fBeginElements(MeshFile ); - //for every face of tetrahedron we create a list of its nodes - int* nodes_id = new int[4]; - - - for( ModelPart::ConditionsContainerType::iterator it = mMeshConditions.begin(); - it != mMeshConditions.end(); ++it ) - { - for( unsigned int i=0; i<(it)->GetGeometry().size(); i++ ) - nodes_id[i] = (it)->GetGeometry()[i].Id(); - - int n_str=0; - int n_free_surf=0; - - for (unsigned int i=0; i<3; i++) - { - n_free_surf+=int((it)->GetGeometry()[i].FastGetSolutionStepValue(IS_FREE_SURFACE)); - n_str+=int((it)->GetGeometry()[i].FastGetSolutionStepValue(IS_STRUCTURE)); - } - if (n_str==int(it->GetGeometry().size()))// && n_free_surf!=it->GetGeometry().size()) - { - nodes_id[3]=3; - GiD_fWriteElementMat(MeshFile, (it)->Id(), nodes_id); - } - - } - delete [] nodes_id; - GiD_fEndElements(MeshFile); - GiD_fEndMesh(MeshFile); - } - if( mMeshConditions.size() != 0 ) - { - KRATOS_WATCH( mMeshConditions.begin()->GetGeometry().WorkingSpaceDimension() ) - if( mMeshConditions.begin()->GetGeometry().WorkingSpaceDimension() == 3 ) - { - std::cout << "writing a 3D mesh of the faces" << std::endl; - GiD_fBeginMesh(MeshFile, "Surface Fluid Mesh", GiD_3D, GiD_Triangle, 3); - } - else - KRATOS_THROW_ERROR(std::logic_error,"Check your space dimensions",""); - - //now writing the fluid surface mesh - //printing nodes - GiD_fBeginCoordinates(MeshFile); - - GiD_fEndCoordinates(MeshFile); - //printing elements - GiD_fBeginElements(MeshFile); - //for every face of tetrahedron we create a list of its nodes - //int* nodes_id = new int[4]; - - - int* nodes_id = new int[4]; - - - - for( ModelPart::ConditionsContainerType::iterator it = mMeshConditions.begin(); - it != mMeshConditions.end(); ++it ) - { - for( unsigned int i=0; i<(it)->GetGeometry().size(); i++ ) - nodes_id[i] = (it)->GetGeometry()[i].Id(); - int n_fl=0; - int n_str=0; - - for (int i=0; i<3; i++) - { - n_str+=int((it)->GetGeometry()[i].FastGetSolutionStepValue(IS_STRUCTURE)); - n_fl+=int((it)->GetGeometry()[i].FastGetSolutionStepValue(IS_FLUID)); - - } - //if (n_free_surf==it->GetGeometry().size()) - // nodes_id[3]=1; - if (n_fl==int(it->GetGeometry().size())) - { - //the color of water - nodes_id[3]=6; - GiD_fWriteElementMat(MeshFile, (it)->Id(), nodes_id); - } - - } - delete [] nodes_id; - GiD_fEndElements(MeshFile); - GiD_fEndMesh(MeshFile); - } - - KRATOS_CATCH("") - } - - void Reset() - { - mMeshNodes.clear(); - mMeshElements.clear(); - mMeshConditions.clear(); - } - - ModelPart::NodesContainerType GetMeshNodes() - { - return mMeshNodes; - } - - - private: - - ///member variables - GeometryData::KratosGeometryType mGeometryType; - GiD_ElementType mGidElementType; - ModelPart::NodesContainerType mMeshNodes; - ModelPart::ElementsContainerType mMeshElements; - ModelPart::ConditionsContainerType mMeshConditions; - const char* mMeshTitle; -};//class TwoFluidGidMeshContainer - -}// namespace Kratos. - - -#endif // KRATOS_TWOFLUID_GID_IO_BASE_H_INCLUDED defined diff --git a/applications/PFEMapplication/custom_utilities/volume_correction_utils.h b/applications/PFEMapplication/custom_utilities/volume_correction_utils.h deleted file mode 100644 index bd5dc515eda6..000000000000 --- a/applications/PFEMapplication/custom_utilities/volume_correction_utils.h +++ /dev/null @@ -1,265 +0,0 @@ -/* -============================================================================== -KratosPFEMApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - - -/* ********************************************************* -* -* Last Modified by: $Author: rrossi $ -* Date: $Date: 2007-03-06 10:30:31 $ -* Revision: $Revision: 1.2 $ -* -* ***********************************************************/ -#include "includes/model_part.h" - -#if !defined(KRATOS_VOLUME_CORRECTION_UTILS ) -#define KRATOS_VOLUME_CORRECTION_UTILS - - -/* System includes */ - - -/* External includes */ - - -/* Project includes */ -#include "utilities/math_utils.h" - - -namespace Kratos -{ - -/**@name Kratos Globals */ -/*@{ */ - - -/*@} */ -/**@name Type Definitions */ -/*@{ */ - - -/*@} */ - - -/**@name Enum's */ -/*@{ */ - - -/*@} */ -/**@name Functions */ -/*@{ */ - - - -/*@} */ -/**@name Kratos Classes */ -/*@{ */ - -/** Short class definition. -Detail class definition. - - \URL[Example of use html]{ extended_documentation/no_ex_of_use.html} - - \URL[Example of use pdf]{ extended_documentation/no_ex_of_use.pdf} - - \URL[Example of use doc]{ extended_documentation/no_ex_of_use.doc} - - \URL[Example of use ps]{ extended_documentation/no_ex_of_use.ps} - - - \URL[Extended documentation html]{ extended_documentation/no_ext_doc.html} - - \URL[Extended documentation pdf]{ extended_documentation/no_ext_doc.pdf} - - \URL[Extended documentation doc]{ extended_documentation/no_ext_doc.doc} - - \URL[Extended documentation ps]{ extended_documentation/no_ext_doc.ps} - - -*/ -class VolumeCorrectionUtils -{ -public: - /**@name Type Definitions */ - /*@{ */ - typedef ModelPart::NodesContainerType NodesArrayType; - typedef ModelPart::ConditionsContainerType ConditionsArrayType; - /*@} */ - /**@name Life Cycle - */ - /*@{ */ - - /** Constructor. - */ - - - /** Destructor. - */ - - /*@} */ - /**@name Operators - */ - /*@{ */ - - - /*@} */ - /**@name Operations */ - /*@{ */ - - //*********************************************************************** - //*********************************************************************** - void CorrectVolume(double old_volume, double new_volume, ModelPart::NodesContainerType& nodes) - { - KRATOS_TRY - - double delta_vol = new_volume - old_volume; - - //calculate the total area of the free surface by using the NORMAL - double area_free_surf = 0.0; - - for(ModelPart::NodesContainerType::iterator it = nodes.begin(); it!=nodes.end(); it++) - { - if(it->FastGetSolutionStepValue(IS_FREE_SURFACE) == 1 && - (it->FastGetSolutionStepValue(NEIGHBOUR_NODES)).size() != 0 ) - { - const array_1d& An = it->FastGetSolutionStepValue(NORMAL); - area_free_surf += norm_2(An); - } - } - - double h_node = -delta_vol / area_free_surf; - KRATOS_WATCH(delta_vol); - KRATOS_WATCH(area_free_surf); - KRATOS_WATCH(h_node); - for(ModelPart::NodesContainerType::iterator it = nodes.begin(); it!=nodes.end(); it++) - { - if(it->FastGetSolutionStepValue(IS_FREE_SURFACE) == 1 && - (it->FastGetSolutionStepValue(NEIGHBOUR_NODES)).size() != 0 ) - { - const array_1d& An = it->FastGetSolutionStepValue(NORMAL); - double Aloc = norm_2(An); - - if(Aloc > 1.0e-15) - { - array_1d& disp = it->FastGetSolutionStepValue(DISPLACEMENT); - - double temp = h_node/Aloc; - noalias(disp) += temp * An; - } - } - } - - KRATOS_CATCH("") - - } - - - - /*@} */ - /**@name Acces */ - /*@{ */ - - - /*@} */ - /**@name Inquiry */ - /*@{ */ - - - /*@} */ - /**@name Friends */ - /*@{ */ - - - /*@} */ - -private: - /**@name Static Member Variables */ - /*@{ */ - - - /*@} */ - /**@name Member Variables */ - /*@{ */ - - /*@} */ - /**@name Private Operators*/ - /*@{ */ - - - /*@} */ - /**@name Private Operations*/ - /*@{ */ - - - /*@} */ - /**@name Private Acces */ - /*@{ */ - - - /*@} */ - /**@name Private Inquiry */ - /*@{ */ - - - /*@} */ - /**@name Un accessible methods */ - /*@{ */ - - //VolumeCorrectionUtils(void); - - //VolumeCorrectionUtils(VolumeCorrectionUtils& rSource); - - - /*@} */ - -}; /* Class ClassName */ - -/*@} */ - -/**@name Type Definitions */ -/*@{ */ - - -/*@} */ - -} /* namespace Kratos.*/ - -#endif /* KRATOS_VOLUME_CORRECTION_UTILS defined */ - diff --git a/applications/PFEMapplication/python_scripts/pfem_solver_ale.py b/applications/PFEMapplication/python_scripts/pfem_solver_ale.py deleted file mode 100644 index 58fadabc43d7..000000000000 --- a/applications/PFEMapplication/python_scripts/pfem_solver_ale.py +++ /dev/null @@ -1,717 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * -import time - - -def AddVariables(model_part): - model_part.AddNodalSolutionStepVariable(NORMAL) - model_part.AddNodalSolutionStepVariable(NORMAL_TO_WALL) - model_part.AddNodalSolutionStepVariable(DISPLACEMENT) - model_part.AddNodalSolutionStepVariable(VELOCITY) - model_part.AddNodalSolutionStepVariable(FRACT_VEL) - model_part.AddNodalSolutionStepVariable(MESH_VELOCITY) - model_part.AddNodalSolutionStepVariable(PRESSURE) - model_part.AddNodalSolutionStepVariable(PRESSURE_OLD_IT); - model_part.AddNodalSolutionStepVariable(PRESS_PROJ); - model_part.AddNodalSolutionStepVariable(CONV_PROJ); -# model_part.AddNodalSolutionStepVariable(NODAL_AREA); - model_part.AddNodalSolutionStepVariable(NODAL_MASS); - model_part.AddNodalSolutionStepVariable(BODY_FORCE); - model_part.AddNodalSolutionStepVariable(DENSITY); - model_part.AddNodalSolutionStepVariable(VISCOSITY); - model_part.AddNodalSolutionStepVariable(IS_STRUCTURE); - model_part.AddNodalSolutionStepVariable(IS_BOUNDARY); - model_part.AddNodalSolutionStepVariable(IS_FREE_SURFACE); - model_part.AddNodalSolutionStepVariable(IS_FLUID); - model_part.AddNodalSolutionStepVariable(IS_INTERFACE); - model_part.AddNodalSolutionStepVariable(NODAL_H); - model_part.AddNodalSolutionStepVariable(ARRHENIUS); - model_part.AddNodalSolutionStepVariable(EXTERNAL_PRESSURE); - print("variables for the incompressible fluid solver added correctly") - - -def AddDofs(model_part): - for node in model_part.Nodes: - # adding dofs - node.AddDof(PRESSURE); - node.AddDof(FRACT_VEL_X); - node.AddDof(FRACT_VEL_Y); - node.AddDof(FRACT_VEL_Z); - node.AddDof(VELOCITY_X); - node.AddDof(VELOCITY_Y); - node.AddDof(VELOCITY_Z); - - node.AddDof(IS_STRUCTURE); - print("dofs for the incompressible fluid solver added correctly") - - -class PFEMSolver: - - def __init__(self, model_part, OuputName, box_corner1, box_corner2, domain_size): - model_part.ProcessInfo.SetValue(DYNAMIC_TAU, 0.001); - - self.domain_size = domain_size - self.model_part = model_part - self.output_name = OuputName - self.pure_lagrangian = False - self.correct_volume = True - self.prediction_order = 2 - self.echo_level = 0 - - self.mesh_every_nsteps = 10; - self.substep = 0; - - if(domain_size == 2): - self.Mesher = TriGenPFEMModeler() -# self.Mesher = TriGenModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 9, 18) - elif (domain_size == 3): - self.Mesher = TetGenPfemModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 20, 30) - - self.Hfinder = FindNodalHProcess(model_part); - self.ActOnWalls = ActOnWallsNodalProcess(model_part) - - self.add_nodes = True - self.remove_nodes = True - number_of_smoothing_loops = 20 - reduction_factor = 1.0 - self.CoordinateSmoother = CoordinateLaplacianSmootherProcess(model_part, number_of_smoothing_loops, reduction_factor); - - self.MeshMover = MoveMeshProcess(model_part); - self.EraseNodes = NodeEraseProcess(model_part); - - self.NormalTools = NormalCalculationUtils() - self.NormalToWall = NormalToWallCalculationUtils() - self.PfemUtils = PfemUtils() - - if(self.correct_volume): - self.VolumeCorrectionTools = VolumeCorrectionUtils() - - self.alpha_shape = 1.5 - - # saving the limits of the box (all the nodes external to this will be erased) - self.box_corner1 = box_corner1 - self.box_corner2 = box_corner2 - - # assignation of parameters to be used - self.vel_toll = 0.0001; - self.press_toll = 0.001; - self.max_vel_its = 7; - self.max_press_its = 3; - self.time_order = 1; - self.CalculateReactions = False; - self.ReformDofAtEachIteration = True; - self.CalculateNormDxFlag = True; - self.laplacian_form = 3; # 1 = laplacian, 2 = Discrete Laplacian; 3 = discrete laplacian + tau=dt - self.predictor_corrector = False; - self.smooth = True - self.h_factor = 0.2 # nodes closer than h_factor * H will be erased - - self.step = 0 - - self.displacement_correction_afterstep4 = False - - self.eulerian_lagrangian = True - - self.uzawa_term_is_active = False - - # aux variable - self.normDx = 0.0 - self.total_remeshing_time = 0.00 - - # definition of the solvers - pDiagPrecond = DiagonalPreconditioner() - self.velocity_linear_solver = BICGSTABSolver(1e-6, 5000, pDiagPrecond) - -# pILUPrecond = ILU0Preconditioner() -# self.pressure_linear_solver = BICGSTABSolver(1e-3, 5000,pILUPrecond) - - pDiagPrecond = DiagonalPreconditioner() - self.pressure_linear_solver = BICGSTABSolver(1e-4, 5000, pDiagPrecond) - # self.pressure_linear_solver = TFQMRSolver(1e-9, 5000,pDiagPrecond) - # pressure_linear_solver = SkylineLUFactorizationSolver() - - self.projections_are_initialized = True; - - def EstimateDeltaTime(self, min_dt, max_dt): - return (self.PfemUtils).EstimateDeltaTime(min_dt, max_dt, self.model_part) - - def Initialize(self, DeltaTime, output_time_increment): - - print("Initializing PFEM solver") - - # finding nodal connectivity - (self.neigh_finder).Execute(); - - domain_size = self.domain_size - - # time increment for output - self.output_time_increment = output_time_increment - self.next_output_time = self.output_time_increment - - # prediction of the structural motion - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size); - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size); - - # calculating the Hmap after reading the gid mesh - (self.Hfinder).Execute() - - # identify the fluid nodes - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # erase the nodes out of the bounding box - print("bounding box limits") - print(self.box_corner1) - print(self.box_corner2) - - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.EraseNodes).Execute(); - - # remesh - if(self.domain_size == 2): - (self.Mesher).ReGenerateMesh("Fluid2D", "Condition2D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - else: - (self.Mesher).ReGenerateMesh("Fluid3D", "Condition3D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - -# (self.Mesher).ReGenerateMesh(self.model_part,self.alpha_shape) - print("remeshing in initalize performed successfully") - - print("*************************************************************") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # initializing the tool to allow the lagrangian inlet - # self.LagrangianInlet = LagrangianInletProcess(self.model_part,DeltaTime); - - print("time order = ", self.time_order) - # initializing the fluid solver - print(self.vel_toll) - self.domain_size = int(self.domain_size) - self.laplacian_form = int(self.laplacian_form) - solver_configuration = FractionalStepConfiguration(self.model_part, self.velocity_linear_solver, self.pressure_linear_solver, self.domain_size, self.laplacian_form) - - self.ReformDofAtEachIteration = bool(self.ReformDofAtEachIteration) - self.vel_toll = float(self.vel_toll) - self.press_toll = float(self.press_toll) - self.max_vel_its = int(self.max_vel_its) - self.max_press_its = int(self.max_press_its) - self.time_order = int(self.time_order) - self.domain_size = int(self.domain_size) - self.predictor_corrector = bool(self.predictor_corrector) - self.fluid_solver = FractionalStepStrategy(self.model_part, solver_configuration, self.ReformDofAtEachIteration, self.vel_toll, self.press_toll, self.max_vel_its, self.max_press_its, self.time_order, self.domain_size, self.predictor_corrector) - -# self.fluid_solver = ResidualBasedFluidStrategyCoupled(self.model_part,self.velocity_linear_solver,self.pressure_linear_solver,self.CalculateReactions,self.ReformDofAtEachIteration,self.CalculateNormDxFlag,self.vel_toll,self.press_toll, self.max_vel_its,self.max_press_its, self.time_order,self.domain_size, self.laplacian_form, self.predictor_corrector) -# self.fluid_solver = ResidualBasedFluidStrategy(self.model_part,self.velocity_linear_solver,self.pressure_linear_solver,self.CalculateReactions,self.ReformDofAtEachIteration,self.CalculateNormDxFlag,self.vel_toll,self.press_toll, self.max_vel_its,self.max_press_its, self.time_order,self.domain_size, self.laplacian_form, self.predictor_corrector) -# self.fluid_solver = FractionalStepStrategy(self.model_part,self.velocity_linear_solver,self.pressure_linear_solver,self.CalculateReactions,self.ReformDofAtEachIteration,self.CalculateNormDxFlag,self.vel_toll,self.press_toll, self.max_vel_its,self.max_press_its, self.time_order,self.domain_size, self.laplacian_form, self.predictor_corrector) -# (self.fluid_solver).SetEchoLevel(self.echo_level) - # determine the original volume - if(self.correct_volume): - [inverted_elements, vol] = self.CheckForInvertedElements() - self.originalvolume = vol - - (self.lagrangian_tools) = LagrangianUtils() - (self.VariableUtils) = VariableUtils() - - self.utilities = VariableUtils() - - print("Intialize PFEM solver terminated") - - # - def Solve(self, time, gid_io): - self.FindNeighbours() - - if(self.eulerian_lagrangian): - print("SONO QUI") - self.EulerianLagrangianPredictionStep(time) - else: - print("SONO LI") - self.PredictionStep(time) - - self.FluidSolutionStep() - - self.PostSolutionStep() - - self.OutputStep(time, gid_io) - - # - def CheckForInvertedElements(self): - volume = (self.PfemUtils).CalculateVolume(self.model_part, self.domain_size) - inverted_elements = False - if(volume < 0.0): - volume = - volume - inverted_elements = True - return [inverted_elements, volume] - - # - def ReduceTimeStep(self, model_part): - (self.PfemUtils).ReduceTimeStep(model_part); - - # - def FindNeighbours(self): - (self.neigh_finder).Execute(); - - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def PredictionStep(self, time): - - if(self.step > 2): - print("*************** second order prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - print("pfem_solver_ale line 257") - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - print("pfem_solver_ale line 259") - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - print("pfem_solver_ale line 261") - # performing a first order prediction of the fluid displacement - (self.PfemUtils).Predict(self.model_part) - (self.MeshMover).Execute(); - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - (self.ActOnWalls).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - # improve the prediction to reach second order - if(self.prediction_order == 2 and self.step > 2): - # lagrangian improvement of the correction - self.LagrangianCorrection() - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # verify if the mesh is suitable to go on calculations and eventually remesh - [inverted_elements, vol] = self.CheckForInvertedElements() - print("vol = ", vol) - if(inverted_elements): - self.Remesh() - print("********************************************* ") - print("**** PERFORMED EMERGENCY REMESH ************* ") - print("********************************************* ") - - self.CalculateProjections() - - # - def Remesh(self): - remeshing_start_time = time.time() - - # clearing the sytem matrices as the connectivity will change - (self.fluid_solver).Clear() - print("fluid solver") - - # erase the nodes out of the bounding box - print("h_factor=", self.h_factor) - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.PfemUtils).MarkExcessivelyCloseNodes((self.model_part).Nodes, self.h_factor); - (self.EraseNodes).Execute(); - print("erase is executed") - - (self.neigh_finder).ClearNeighbours(); - print("neighbours are cleared") - - # erase all conditions and elements prior to remeshing - ((self.model_part).Elements).clear(); - ((self.model_part).Conditions).clear(); - print("elements are cleared") - - # remesh - #(self.Mesher).ReGenerateMesh(self.model_part,self.alpha_shape) - if(self.domain_size == 2): - (self.Mesher).ReGenerateMesh("Fluid2D", "Condition2D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - else: - (self.Mesher).ReGenerateMesh("Fluid3D", "Condition3D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - - print(self.model_part) - - print("a") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - print("b") - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form); - print("c") - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - print("d") - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - print("e") - - self.substep = 0; - - remeshing_end_time = time.time() - - print("Remeshing time :", remeshing_end_time - remeshing_start_time) - self.total_remeshing_time += remeshing_end_time - remeshing_start_time - print("Total remeshing time :", self.total_remeshing_time) - - # - def SolutionStep1(self): - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - self.normDx = 0.0 # [0] = 0.00; self.normDx[1] = 0.00; self.normDx[2] = 0.00; - is_converged = False - iteration = 0 - - # iterative solution of the velocity - while(is_converged == False and iteration < self.max_vel_its): - self.normDx = (self.fluid_solver).FractionalVelocityIteration(); - is_converged = (self.fluid_solver).ConvergenceCheck(self.normDx, self.vel_toll); - iteration = iteration + 1 - - # - def LagrangianCorrection(self): - print("Lagrangian prediction") - - # step initialization for the fluid solution - (self.fluid_solver).ApplyFractionalVelocityFixity() - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - print("before lagrangian solution") - - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - self.normDx = (self.fluid_solver).FractionalVelocityIteration(); - - is_converged = (self.fluid_solver).ConvergenceCheck(self.normDx, self.vel_toll); - - (self.lagrangian_tools).CalculateStep1DisplacementCorrection((self.model_part)) - print("after lagrangian solution") - - # deleting unnecessary memory -# (self.fluid_solver).Clear() - - # return normDx - - # - # ALE solution of the fluid on the moving domain - def FluidSolutionStep(self): - (self.fluid_solver).ApplyFractionalVelocityFixity() - - if(self.step < self.time_order + 2): - print("IterativeSolve") -# self.PredictorCorrectorFluidSolutionStep() - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - - (self.fluid_solver).AssignInitialStepValues(); - print("adsdfsafafds") - (self.fluid_solver.IterativeSolve()) - print("qqqq") - - else: - if(self.predictor_corrector == False): - self.PureFractionalStepFluidSolutionStep() - else: - self.PredictorCorrectorFluidSolutionStep() - -# self.step = self.step + 1 - self.substep = self.substep + 1 - -# (self.fluid_solver).Clear() -# if(self.substep == self.mesh_every_nsteps): -# (self.fluid_solver).Clear() - # - def PureFractionalStepFluidSolutionStep(self): - print("PureFractionalStepFluidSolutionStep beginning") - self.SolutionStep1() - print("PureFractionalStepFluidSolutionStep after step1") - - (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - if(self.uzawa_term_is_active): - (self.fluid_solver).SolveStep2_Mp(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - # - # ALE solution of the fluid on the moving domain - def PredictorCorrectorFluidSolutionStep(self): - - print("PredictorCorrectorFluidSolutionStep beginning") - it = 1 - pressure_is_converged = False - while(pressure_is_converged == False and it <= self.max_press_its): - - self.SolutionStep1() - - dp = (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - if(self.uzawa_term_is_active): - (self.fluid_solver).SolveStep2_Mp(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - p_norm = (self.fluid_solver).SavePressureIteration() - - it = it + 1 - - ratio = 0.0 - if(p_norm > 1e-10): - ratio = dp / p_norm - print("********************* ", it, " ******", ratio, " **************") - if(ratio < self.press_toll): - pressure_is_converged = True - - # - # - # nodes in the inlet introduced and ALE acceleration calculated - def PostSolutionStep(self): - self.step = self.step + 1 - print("doing nothing in the post step") - # lagrangian fluid step - #(self.LagrangianInlet).Execute(); - - # calculate the spatial (ALE) acceleration -# if(self.domain_size == 2): -# (self.PfemUtils).CalculateSpatialALEAcceleration2D(self.model_part) -# else: -# (self.PfemUtils).CalculateSpatialALEAcceleration3D(self.model_part) - - # - def OutputStep(self, time, gid_io): -# if(time >= self.next_output_time): - if(time >= self.next_output_time): - self.next_output_time = self.next_output_time + self.output_time_increment; - - # writing mesh - gid_io.InitializeMesh(time); - gid_io.WriteNodeMesh((self.model_part).GetMesh()); - gid_io.WriteMesh((self.model_part).GetMesh()); - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(time, (self.model_part).GetMesh()); - - gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(VISCOSITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(DENSITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); - - gid_io.Flush() - gid_io.FinalizeResults() - -# file_name = self.output_name -# file_name = file_name + str(time) -# -# print "before changing name" -# gid_io.ChangeOutputName(file_name,GiDPostMode.GiD_PostBinary); -# print "name changed" -# my_mesh = (self.model_part).GetMesh() -# print my_mesh -# print self.model_part -# gid_io.WriteMesh((self.model_part).GetMesh(),self.domain_size,GiDPostMode.GiD_PostBinary); -# print "mesh written" -# gid_io.WriteNodalResults(NODAL_AREA, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL_TO_WALL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_LAGRANGIAN_INLET, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NODAL_H, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(MESH_VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(ACCELERATION, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(BODY_FORCE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESS_PROJ, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(CONV_PROJ, (self.model_part).Nodes, time, 0); -# -# print "results finished" -# gid_io.Flush() -# gid_io.CloseResultFile(); - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def EulerianLagrangianPredictionStep(self, time): - - print(self.step) - if(self.step > 2): - print("*************** eulerian-lagrangian prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - print("ln566") - # performing a first order prediction of the fluid displacement - # without moving the mesh - (self.PfemUtils).Predict(self.model_part) - - print("ln571") - # lagrangian improvement of the displacements - if(self.step > 2): - # copying the velocity to the mesh_velocity to set to zero the convective part) - (self.utilities).CopyVectorVar(VELOCITY, MESH_VELOCITY, (self.model_part).Nodes); - self.LagrangianCorrection() - - print("ln522") - (self.MeshMover).Execute(); - - print("ln525") - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - print("ln529") - (self.ActOnWalls).Execute(); - - print("ln 532") - (self.MeshMover).Execute(); - - print("ln529") - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - self.CalculateProjections() - - # - def CalculateProjections(self): - (self.PfemUtils).CalculateNodalMass(self.model_part, self.domain_size); - (self.fluid_solver).SolveStep3() - print("Projections were calculated") - - -# -# in this step the node position is predicted, the mesh is regenerated -# and the boundary conditions are imposed -# def PredictionStep(self,time): -# domain_size = self.domain_size -# -# calculate normals -# conditions = (self.model_part).Conditions -# (self.NormalTools).CalculateOnSimplex(conditions,domain_size) -# (self.NormalToWall).CalculateNormalToWall(conditions,domain_size) -# -# performing a first order prediction of the fluid displacement -# print "****************************" , self.prediction_order -# if( self.prediction_order == 12): -# (self.PfemUtils).Predict(self.model_part) -# (self.utilities).SetToZero_VectorVar(MESH_VELOCITY,(self.model_part).Nodes); -# if(self.step > 2): -# print "eulerian second order prediction" -# self.LagrangianCorrection() -# elif( self.prediction_order == 2): -# print "second order prediction" -# (self.PfemUtils).QuasiLagrangianMove(self.model_part) -# if(self.step > 2): -# -# (self.PfemUtils).Predict(self.model_part) -# (self.MeshMover).Execute(); -# -# calculating projections on the updated mesh position -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# if(self.step > 2): -# self.LagrangianCorrection() -# elif( self.prediction_order == 1): -# print "first order prediction" -# (self.PfemUtils).Predict(self.model_part) -# else: -# print "zeroth order prediction - no motion!!" -# -# (self.MeshMover).Execute(); -# -# (self.PfemUtils).MoveLonelyNodes(self.model_part) -# (self.MeshMover).Execute(); -# -# -# ensure that no node gets too close to the walls -# (self.ActOnWalls).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# smooth the final position of the nodes to homogeneize the mesh distribution -# (self.CoordinateSmoother).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# calculating projections on the updated mesh -# if(self.step > 2): -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# print "pfem_solver_ale line 262" -# print self.model_part -# -# regenerate the mesh -# print self.substep -# self.Remesh() - - - - -# -# if(self.correct_volume == True): -# calculate the new volume (after moving and alpha shape) -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# correct the volume to cure the volume loss -# (self.VolumeCorrectionTools).CorrectVolume(self.originalvolume, vol, (self.model_part).Nodes) -# (self.MeshMover).Execute(); diff --git a/applications/PFEMapplication/python_scripts/pfem_solver_ale_antonia.py b/applications/PFEMapplication/python_scripts/pfem_solver_ale_antonia.py deleted file mode 100644 index 0e8ce93d21cb..000000000000 --- a/applications/PFEMapplication/python_scripts/pfem_solver_ale_antonia.py +++ /dev/null @@ -1,699 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * - - -def AddVariables(model_part): - model_part.AddNodalSolutionStepVariable(NORMAL) - model_part.AddNodalSolutionStepVariable(NORMAL_TO_WALL) - model_part.AddNodalSolutionStepVariable(DISPLACEMENT) - model_part.AddNodalSolutionStepVariable(VELOCITY) - model_part.AddNodalSolutionStepVariable(FRACT_VEL) - model_part.AddNodalSolutionStepVariable(MESH_VELOCITY); - model_part.AddNodalSolutionStepVariable(PRESSURE); - model_part.AddNodalSolutionStepVariable(PRESSURE_OLD_IT); - model_part.AddNodalSolutionStepVariable(PRESS_PROJ); - model_part.AddNodalSolutionStepVariable(CONV_PROJ); -# model_part.AddNodalSolutionStepVariable(NODAL_AREA); - model_part.AddNodalSolutionStepVariable(NODAL_MASS); - model_part.AddNodalSolutionStepVariable(BODY_FORCE); - model_part.AddNodalSolutionStepVariable(DENSITY); - model_part.AddNodalSolutionStepVariable(VISCOSITY); - model_part.AddNodalSolutionStepVariable(IS_STRUCTURE); - model_part.AddNodalSolutionStepVariable(IS_BOUNDARY); - model_part.AddNodalSolutionStepVariable(IS_FREE_SURFACE); - model_part.AddNodalSolutionStepVariable(IS_FLUID); - model_part.AddNodalSolutionStepVariable(IS_INTERFACE); - model_part.AddNodalSolutionStepVariable(NODAL_H); - model_part.AddNodalSolutionStepVariable(ARRHENIUS); - model_part.AddNodalSolutionStepVariable(EXTERNAL_PRESSURE); - print("variables for the incompressible fluid solver added correctly") - - -def AddDofs(model_part): - for node in model_part.Nodes: - # adding dofs - node.AddDof(PRESSURE); - node.AddDof(FRACT_VEL_X); - node.AddDof(FRACT_VEL_Y); - node.AddDof(FRACT_VEL_Z); - node.AddDof(VELOCITY_X); - node.AddDof(VELOCITY_Y); - node.AddDof(VELOCITY_Z); - - node.AddDof(IS_STRUCTURE); - print("dofs for the incompressible fluid solver added correctly") - - -class PFEMSolver: - - def __init__(self, model_part, box_corner1, box_corner2, domain_size): - - self.domain_size = domain_size - self.model_part = model_part - self.pure_lagrangian = False - self.correct_volume = True - self.prediction_order = 2 - self.echo_level = 0 - - self.mesh_every_nsteps = 10; - self.substep = 0; - - model_part.ProcessInfo.SetValue(DYNAMIC_TAU, 0.001); - - if(domain_size == 2): - self.Mesher = TriGenPFEMModeler() -# self.Mesher = TriGenModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 9, 18) - elif (domain_size == 3): - self.Mesher = TetGenPfemModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 20, 30) - - self.Hfinder = FindNodalHProcess(model_part); - self.ActOnWalls = ActOnWallsNodalProcess(model_part) - - self.add_nodes = True - self.remove_nodes = True - number_of_smoothing_loops = 20 - reduction_factor = 1.0 - self.CoordinateSmoother = CoordinateLaplacianSmootherProcess(model_part, number_of_smoothing_loops, reduction_factor); - - self.MeshMover = MoveMeshProcess(model_part); - self.EraseNodes = NodeEraseProcess(model_part); - - self.NormalTools = NormalCalculationUtils() - self.NormalToWall = NormalToWallCalculationUtils() - self.PfemUtils = PfemUtils() - - if(self.correct_volume): - self.VolumeCorrectionTools = VolumeCorrectionUtils() - - self.alpha_shape = 1.5 - - # saving the limits of the box (all the nodes external to this will be erased) - self.box_corner1 = box_corner1 - self.box_corner2 = box_corner2 - - # assignation of parameters to be used - self.vel_toll = 0.0001; - self.press_toll = 0.001; - self.max_vel_its = 7; - self.max_press_its = 3; - self.time_order = 1; - self.CalculateReactions = False; - self.ReformDofAtEachIteration = True; - self.CalculateNormDxFlag = True; - self.laplacian_form = 3; # 1 = laplacian, 2 = Discrete Laplacian; 3 = discrete laplacian + tau=dt - self.predictor_corrector = False; - self.smooth = True - self.h_factor = 0.2 # nodes closer than h_factor * H will be erased - - self.step = 0 - - self.displacement_correction_afterstep4 = False - - self.eulerian_lagrangian = True - - self.uzawa_term_is_active = False - - # aux variable - self.normDx = Array3() - - # definition of the solvers - pDiagPrecond = DiagonalPreconditioner() - self.velocity_linear_solver = BICGSTABSolver(1e-6, 5000, pDiagPrecond) - -# pILUPrecond = ILU0Preconditioner() -# self.pressure_linear_solver = BICGSTABSolver(1e-3, 5000,pILUPrecond) - - pDiagPrecond = DiagonalPreconditioner() - self.pressure_linear_solver = BICGSTABSolver(1e-4, 5000, pDiagPrecond) - # self.pressure_linear_solver = TFQMRSolver(1e-9, 5000,pDiagPrecond) - # pressure_linear_solver = SkylineLUFactorizationSolver() - - self.projections_are_initialized = True; - - def EstimateDeltaTime(self, min_dt, max_dt): - return (self.PfemUtils).EstimateDeltaTime(min_dt, max_dt, self.model_part) - - def Initialize(self, DeltaTime, output_time_increment): - - print("Initializing PFEM solver") - - # finding nodal connectivity - (self.neigh_finder).Execute(); - - domain_size = self.domain_size - - # time increment for output - self.output_time_increment = output_time_increment - self.next_output_time = self.output_time_increment - - # prediction of the structural motion - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size); - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size); - - # calculating the Hmap after reading the gid mesh - (self.Hfinder).Execute() - - # identify the fluid nodes - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # erase the nodes out of the bounding box - print("bounding box limits") - print(self.box_corner1) - print(self.box_corner2) - - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.EraseNodes).Execute(); - - # remesh - if(self.domain_size == 2): - (self.Mesher).ReGenerateMesh("Fluid2D", "Condition2D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - else: - (self.Mesher).ReGenerateMesh("Fluid3D", "Condition3D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - -# (self.Mesher).ReGenerateMesh(self.model_part,self.alpha_shape) - print("remeshing in initalize performed successfully") - - print("*************************************************************") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # initializing the tool to allow the lagrangian inlet - # self.LagrangianInlet = LagrangianInletProcess(self.model_part,DeltaTime); - - print("time order = ", self.time_order) - # initializing the fluid solver - print(self.vel_toll) -# self.fluid_solver = ResidualBasedFluidStrategyCoupled(self.model_part,self.velocity_linear_solver,self.pressure_linear_solver,self.CalculateReactions,self.ReformDofAtEachIteration,self.CalculateNormDxFlag,self.vel_toll,self.press_toll, self.max_vel_its,self.max_press_its, self.time_order,self.domain_size, self.laplacian_form, self.predictor_corrector) - self.fluid_solver = ResidualBasedFluidStrategy(self.model_part, self.velocity_linear_solver, self.pressure_linear_solver, self.CalculateReactions, self.ReformDofAtEachIteration, self.CalculateNormDxFlag, self.vel_toll, self.press_toll, self.max_vel_its, self.max_press_its, self.time_order, self.domain_size, self.laplacian_form, self.predictor_corrector) - (self.fluid_solver).SetEchoLevel(self.echo_level) - - # determine the original volume - if(self.correct_volume): - [inverted_elements, vol] = self.CheckForInvertedElements() - self.originalvolume = vol - - (self.lagrangian_tools) = LagrangianUtils() - (self.VariableUtils) = VariableUtils() - - self.utilities = VariableUtils() - - print("Intialize PFEM solver terminated") - - # - def Solve(self, time, gid_io): - self.FindNeighbours() - - if(self.eulerian_lagrangian): - print("SONO QUI") - self.EulerianLagrangianPredictionStep(time) - else: - print("SONO LI") - self.PredictionStep(time) - - self.FluidSolutionStep() - - self.PostSolutionStep() - -# self.OutputStep(time,gid_io) - - # - def CheckForInvertedElements(self): - volume = (self.PfemUtils).CalculateVolume(self.model_part, self.domain_size) - inverted_elements = False - if(volume < 0.0): - volume = - volume - inverted_elements = True - return [inverted_elements, volume] - - # - def ReduceTimeStep(self, model_part): - (self.PfemUtils).ReduceTimeStep(model_part); - - # - def FindNeighbours(self): - (self.neigh_finder).Execute(); - - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def PredictionStep(self, time): - - if(self.step > 2): - print("*************** second order prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - print("pfem_solver_ale line 257") - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - print("pfem_solver_ale line 259") - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - print("pfem_solver_ale line 261") - # performing a first order prediction of the fluid displacement - (self.PfemUtils).Predict(self.model_part) - (self.MeshMover).Execute(); - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - (self.ActOnWalls).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - # improve the prediction to reach second order - if(self.prediction_order == 2 and self.step > 2): - # lagrangian improvement of the correction - self.LagrangianCorrection() - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # verify if the mesh is suitable to go on calculations and eventually remesh - [inverted_elements, vol] = self.CheckForInvertedElements() - print("vol = ", vol) - if(inverted_elements): - self.Remesh() - print("********************************************* ") - print("**** PERFORMED EMERGENCY REMESH ************* ") - print("********************************************* ") - - self.CalculateProjections() - - # - def Remesh(self): - # clearing the sytem matrices as the connectivity will change - (self.fluid_solver).Clear() - print("fluid solver") - - # erase the nodes out of the bounding box - print("h_factor=", self.h_factor) - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.PfemUtils).MarkExcessivelyCloseNodes((self.model_part).Nodes, self.h_factor); - (self.EraseNodes).Execute(); - print("erase is executed") - - (self.neigh_finder).ClearNeighbours(); - print("neighbours are cleared") - - # erase all conditions and elements prior to remeshing - ((self.model_part).Elements).clear(); - ((self.model_part).Conditions).clear(); - print("elements are cleared") - - # remesh - #(self.Mesher).ReGenerateMesh(self.model_part,self.alpha_shape) - if(self.domain_size == 2): - (self.Mesher).ReGenerateMesh("Fluid2D", "Condition2D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - else: - (self.Mesher).ReGenerateMesh("Fluid3D", "Condition3D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - - print(self.model_part) - - print("a") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - print("b") - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form); - print("c") - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - print("d") - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - print("e") - - self.substep = 0; - print("end of function Remesh") - - # - def SolutionStep1(self): - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - self.normDx[0] = 0.00 - self.normDx[1] = 0.00 - self.normDx[2] = 0.00 - is_converged = False - iteration = 0 - - # iterative solution of the velocity - while(is_converged == False and iteration < self.max_vel_its): - (self.fluid_solver).FractionalVelocityIteration(self.normDx); - is_converged = (self.fluid_solver).ConvergenceCheck(self.normDx, self.vel_toll); - iteration = iteration + 1 - - # - def LagrangianCorrection(self): - print("Lagrangian prediction") - - # step initialization for the fluid solution - (self.fluid_solver).ApplyFractionalVelocityFixity() - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - print("before lagrangian solution") - - self.normDx[0] = 0.00 - self.normDx[1] = 0.00 - self.normDx[2] = 0.00 - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).FractionalVelocityIteration(self.normDx); - - is_converged = (self.fluid_solver).ConvergenceCheck(self.normDx, self.vel_toll); - - (self.lagrangian_tools).CalculateStep1DisplacementCorrection((self.model_part)) - print("after lagrangian solution") - - # deleting unnecessary memory -# (self.fluid_solver).Clear() - - # return normDx - - # - # ALE solution of the fluid on the moving domain - def FluidSolutionStep(self): - (self.fluid_solver).ApplyFractionalVelocityFixity() - - if(self.step < self.time_order + 2): - print("IterativeSolve") -# self.PredictorCorrectorFluidSolutionStep() - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - - (self.fluid_solver).AssignInitialStepValues(); - print("adsdfsafafds") - (self.fluid_solver.IterativeSolve()) - print("qqqq") - - else: - if(self.predictor_corrector == False): - self.PureFractionalStepFluidSolutionStep() - else: - self.PredictorCorrectorFluidSolutionStep() - -# self.step = self.step + 1 - self.substep = self.substep + 1 - -# (self.fluid_solver).Clear() -# if(self.substep == self.mesh_every_nsteps): -# (self.fluid_solver).Clear() - # - def PureFractionalStepFluidSolutionStep(self): - print("PureFractionalStepFluidSolutionStep beginning") - self.SolutionStep1() - print("PureFractionalStepFluidSolutionStep after step1") - - (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - if(self.uzawa_term_is_active): - (self.fluid_solver).SolveStep2_Mp(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - # - # ALE solution of the fluid on the moving domain - def PredictorCorrectorFluidSolutionStep(self): - - print("PredictorCorrectorFluidSolutionStep beginning") - it = 1 - pressure_is_converged = False - while(pressure_is_converged == False and it <= self.max_press_its): - - self.SolutionStep1() - - dp = (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - if(self.uzawa_term_is_active): - (self.fluid_solver).SolveStep2_Mp(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - p_norm = (self.fluid_solver).SavePressureIteration() - - it = it + 1 - - ratio = 0.0 - if(p_norm > 1e-10): - ratio = dp / p_norm - print("********************* ", it, " ******", ratio, " **************") - if(ratio < self.press_toll): - pressure_is_converged = True - - # - # - # nodes in the inlet introduced and ALE acceleration calculated - def PostSolutionStep(self): - self.step = self.step + 1 - print("doing nothing in the post step") - # lagrangian fluid step - #(self.LagrangianInlet).Execute(); - - # calculate the spatial (ALE) acceleration -# if(self.domain_size == 2): -# (self.PfemUtils).CalculateSpatialALEAcceleration2D(self.model_part) -# else: -# (self.PfemUtils).CalculateSpatialALEAcceleration3D(self.model_part) - - # - def OutputStep(self, time, gid_io): -# if(time >= self.next_output_time): - if(time >= self.next_output_time): - self.next_output_time = self.next_output_time + self.output_time_increment; - - # writing mesh - gid_io.InitializeMesh(time); - gid_io.WriteNodeMesh((self.model_part).GetMesh()); - gid_io.WriteMesh((self.model_part).GetMesh()); - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(time, (self.model_part).GetMesh()); - - gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(VISCOSITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(DENSITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); - - gid_io.Flush() - gid_io.FinalizeResults() - -# file_name = self.output_name -# file_name = file_name + str(time) -# -# print "before changing name" -# gid_io.ChangeOutputName(file_name,GiDPostMode.GiD_PostBinary); -# print "name changed" -# my_mesh = (self.model_part).GetMesh() -# print my_mesh -# print self.model_part -# gid_io.WriteMesh((self.model_part).GetMesh(),self.domain_size,GiDPostMode.GiD_PostBinary); -# print "mesh written" -# gid_io.WriteNodalResults(NODAL_AREA, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL_TO_WALL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_LAGRANGIAN_INLET, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NODAL_H, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(MESH_VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(ACCELERATION, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(BODY_FORCE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESS_PROJ, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(CONV_PROJ, (self.model_part).Nodes, time, 0); -# -# print "results finished" -# gid_io.Flush() -# gid_io.CloseResultFile(); - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def EulerianLagrangianPredictionStep(self, time): - - print(self.step) - if(self.step > 2): - print("*************** eulerian-lagrangian prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - print("ln566") - # performing a first order prediction of the fluid displacement - # without moving the mesh - (self.PfemUtils).Predict(self.model_part) - - print("ln571") - # lagrangian improvement of the displacements - if(self.step > 2): - # copying the velocity to the mesh_velocity to set to zero the convective part) - (self.utilities).CopyVectorVar(VELOCITY, MESH_VELOCITY, (self.model_part).Nodes); - self.LagrangianCorrection() - - print("ln522") - (self.MeshMover).Execute(); - - print("ln525") - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - print("ln529") - (self.ActOnWalls).Execute(); - - print("ln 532") - (self.MeshMover).Execute(); - - print("ln529") - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - self.CalculateProjections() - - # - def CalculateProjections(self): - (self.PfemUtils).CalculateNodalMass(self.model_part, self.domain_size); - (self.fluid_solver).SolveStep3() - print("Projections were calculated") - - -# -# in this step the node position is predicted, the mesh is regenerated -# and the boundary conditions are imposed -# def PredictionStep(self,time): -# domain_size = self.domain_size -# -# calculate normals -# conditions = (self.model_part).Conditions -# (self.NormalTools).CalculateOnSimplex(conditions,domain_size) -# (self.NormalToWall).CalculateNormalToWall(conditions,domain_size) -# -# performing a first order prediction of the fluid displacement -# print "****************************" , self.prediction_order -# if( self.prediction_order == 12): -# (self.PfemUtils).Predict(self.model_part) -# (self.utilities).SetToZero_VectorVar(MESH_VELOCITY,(self.model_part).Nodes); -# if(self.step > 2): -# print "eulerian second order prediction" -# self.LagrangianCorrection() -# elif( self.prediction_order == 2): -# print "second order prediction" -# (self.PfemUtils).QuasiLagrangianMove(self.model_part) -# if(self.step > 2): -# -# (self.PfemUtils).Predict(self.model_part) -# (self.MeshMover).Execute(); -# -# calculating projections on the updated mesh position -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# if(self.step > 2): -# self.LagrangianCorrection() -# elif( self.prediction_order == 1): -# print "first order prediction" -# (self.PfemUtils).Predict(self.model_part) -# else: -# print "zeroth order prediction - no motion!!" -# -# (self.MeshMover).Execute(); -# -# (self.PfemUtils).MoveLonelyNodes(self.model_part) -# (self.MeshMover).Execute(); -# -# -# ensure that no node gets too close to the walls -# (self.ActOnWalls).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# smooth the final position of the nodes to homogeneize the mesh distribution -# (self.CoordinateSmoother).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# calculating projections on the updated mesh -# if(self.step > 2): -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# print "pfem_solver_ale line 262" -# print self.model_part -# -# regenerate the mesh -# print self.substep -# self.Remesh() - - - - -# -# if(self.correct_volume == True): -# calculate the new volume (after moving and alpha shape) -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# correct the volume to cure the volume loss -# (self.VolumeCorrectionTools).CorrectVolume(self.originalvolume, vol, (self.model_part).Nodes) -# (self.MeshMover).Execute(); diff --git a/applications/PFEMapplication/python_scripts/pfem_solver_ale_coupled.py b/applications/PFEMapplication/python_scripts/pfem_solver_ale_coupled.py deleted file mode 100644 index 61ecbc11242f..000000000000 --- a/applications/PFEMapplication/python_scripts/pfem_solver_ale_coupled.py +++ /dev/null @@ -1,682 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# -*- coding: utf-8 -*- -# importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * - - -def AddVariables(model_part): - model_part.AddNodalSolutionStepVariable(NORMAL) - model_part.AddNodalSolutionStepVariable(NORMAL_TO_WALL) - model_part.AddNodalSolutionStepVariable(DISPLACEMENT) - model_part.AddNodalSolutionStepVariable(VELOCITY); - model_part.AddNodalSolutionStepVariable(FRACT_VEL); - model_part.AddNodalSolutionStepVariable(MESH_VELOCITY); - model_part.AddNodalSolutionStepVariable(PRESSURE); - model_part.AddNodalSolutionStepVariable(PRESSURE_OLD_IT); - model_part.AddNodalSolutionStepVariable(PRESS_PROJ); - model_part.AddNodalSolutionStepVariable(CONV_PROJ); -# model_part.AddNodalSolutionStepVariable(NODAL_AREA); - model_part.AddNodalSolutionStepVariable(NODAL_MASS); - model_part.AddNodalSolutionStepVariable(BODY_FORCE); - model_part.AddNodalSolutionStepVariable(DENSITY); - model_part.AddNodalSolutionStepVariable(VISCOSITY); - model_part.AddNodalSolutionStepVariable(IS_STRUCTURE); - model_part.AddNodalSolutionStepVariable(IS_BOUNDARY); - model_part.AddNodalSolutionStepVariable(IS_FREE_SURFACE); - model_part.AddNodalSolutionStepVariable(IS_FLUID); - model_part.AddNodalSolutionStepVariable(IS_INTERFACE); - model_part.AddNodalSolutionStepVariable(NODAL_H); - model_part.AddNodalSolutionStepVariable(ARRHENIUS); - print("variables for the incompressible fluid solver added correctly") - - -def AddDofs(model_part): - for node in model_part.Nodes: - # adding dofs - node.AddDof(PRESSURE); - node.AddDof(FRACT_VEL_X); - node.AddDof(FRACT_VEL_Y); - node.AddDof(FRACT_VEL_Z); - node.AddDof(VELOCITY_X); - node.AddDof(VELOCITY_Y); - node.AddDof(VELOCITY_Z); - - node.AddDof(IS_STRUCTURE); - print("dofs for the incompressible fluid solver added correctly") - - -class PFEMSolver: - - def __init__(self, model_part, OuputName, box_corner1, box_corner2, domain_size): - - model_part.ProcessInfo.SetValue(DYNAMIC_TAU, 0.001); - - self.domain_size = domain_size - self.model_part = model_part - self.output_name = OuputName - self.pure_lagrangian = False - self.correct_volume = True - self.prediction_order = 2 - self.echo_level = 0 - self.add_nodes = True - self.remove_nodes = True - - self.mesh_every_nsteps = 10; - self.substep = 0; - - if(domain_size == 2): - self.Mesher = TriGenPFEMModeler() - # self.Mesher = TriGenModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 9, 18) - elif (domain_size == 3): - self.Mesher = TetGenPfemModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 20, 30) - - self.Hfinder = FindNodalHProcess(model_part); - self.ActOnWalls = ActOnWallsNodalProcess(model_part) - - number_of_smoothing_loops = 20 - reduction_factor = 1.0 - self.CoordinateSmoother = CoordinateLaplacianSmootherProcess(model_part, number_of_smoothing_loops, reduction_factor); - - self.MeshMover = MoveMeshProcess(model_part); - self.EraseNodes = NodeEraseProcess(model_part); - - self.NormalTools = NormalCalculationUtils() - self.NormalToWall = NormalToWallCalculationUtils() - self.PfemUtils = PfemUtils() - - if(self.correct_volume): - self.VolumeCorrectionTools = VolumeCorrectionUtils() - - self.alpha_shape = 1.5 - - # saving the limits of the box (all the nodes external to this will be erased) - self.box_corner1 = box_corner1 - self.box_corner2 = box_corner2 - - # assignation of parameters to be used - self.vel_toll = 1e-9; - self.press_toll = 0.001; - self.max_vel_its = 7; - self.max_press_its = 3; - self.time_order = 1; - self.CalculateReactions = False; - self.ReformDofAtEachIteration = True; - self.CalculateNormDxFlag = True; - self.laplacian_form = 3; # 1 = laplacian, 2 = Discrete Laplacian; 3 = discrete laplacian + tau=dt - self.predictor_corrector = False; - self.smooth = True - self.h_factor = 0.2 # nodes closer than h_factor * H will be erased - - self.step = 0 - - self.displacement_correction_afterstep4 = False - - self.eulerian_lagrangian = True - - self.uzawa_term_is_active = False - - # definition of the solvers - pDiagPrecond = DiagonalPreconditioner() - self.velocity_linear_solver = BICGSTABSolver(1e-6, 5000, pDiagPrecond) - -# pILUPrecond = ILU0Preconditioner() -# self.pressure_linear_solver = BICGSTABSolver(1e-3, 5000,pILUPrecond) - - pDiagPrecond = DiagonalPreconditioner() - self.pressure_linear_solver = BICGSTABSolver(1e-4, 5000, pDiagPrecond) - # self.pressure_linear_solver = TFQMRSolver(1e-9, 5000,pDiagPrecond) - # pressure_linear_solver = SkylineLUFactorizationSolver() - - self.projections_are_initialized = True; - - def EstimateDeltaTime(self, min_dt, max_dt): - return (self.PfemUtils).EstimateDeltaTime(min_dt, max_dt, self.model_part) - - def Initialize(self, DeltaTime, output_time_increment): - - print("Initializing PFEM solver") - - # finding nodal connectivity - (self.neigh_finder).Execute(); - - domain_size = self.domain_size - - # time increment for output - self.output_time_increment = output_time_increment - self.next_output_time = self.output_time_increment - - # prediction of the structural motion - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size); - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size); - - # calculating the Hmap after reading the gid mesh - (self.Hfinder).Execute() - - # identify the fluid nodes - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # erase the nodes out of the bounding box - print("bounding box limits") - print(self.box_corner1) - print(self.box_corner2) - - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.EraseNodes).Execute(); - - # remesh - if(self.domain_size == 2): - (self.Mesher).ReGenerateMesh("Fluid2DCoupled", "Condition2D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - else: - - #(self.Mesher).ReGenerateMesh("Fluid3DCoupled","Condition2D",self.model_part,self.EraseNodes, self.alpha_shape) - (self.Mesher).ReGenerateMesh("Fluid3DCoupled", "Condition3D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - print("remeshing in initalize performed successfully") - - print("*************************************************************") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # initializing the tool to allow the lagrangian inlet - # self.LagrangianInlet = LagrangianInletProcess(self.model_part,DeltaTime); - - print("time order = ", self.time_order) - # initializing the fluid solver - print(self.vel_toll) - self.fluid_solver = ResidualBasedFluidStrategyCoupled(self.model_part, self.velocity_linear_solver, self.pressure_linear_solver, self.CalculateReactions, self.ReformDofAtEachIteration, self.CalculateNormDxFlag, self.vel_toll, self.press_toll, self.max_vel_its, self.max_press_its, self.time_order, self.domain_size, self.laplacian_form, self.predictor_corrector) -# self.fluid_solver = ResidualBasedFluidStrategy(self.model_part,self.velocity_linear_solver,self.pressure_linear_solver,self.CalculateReactions,self.ReformDofAtEachIteration,self.CalculateNormDxFlag,self.vel_toll,self.press_toll, self.max_vel_its,self.max_press_its, self.time_order,self.domain_size, self.laplacian_form, self.predictor_corrector) - (self.fluid_solver).SetEchoLevel(self.echo_level) - - # determine the original volume - if(self.correct_volume): - [inverted_elements, vol] = self.CheckForInvertedElements() - self.originalvolume = vol - - (self.lagrangian_tools) = LagrangianUtils() - (self.VariableUtils) = VariableUtils() - - self.utilities = VariableUtils() - - print("Intialize PFEM solver terminated") - - # - def Solve(self, time, gid_io): - self.FindNeighbours() - - if(self.eulerian_lagrangian): - print("SONO QUI") - self.EulerianLagrangianPredictionStep(time) - else: - print("SONO LI") - self.PredictionStep(time) - - self.FluidSolutionStep() - - self.PostSolutionStep() - - self.OutputStep(time, gid_io) - - # - def CheckForInvertedElements(self): - volume = (self.PfemUtils).CalculateVolume(self.model_part, self.domain_size) - inverted_elements = False - if(volume < 0.0): - volume = - volume - inverted_elements = True - return [inverted_elements, volume] - - # - def ReduceTimeStep(self, model_part): - (self.PfemUtils).ReduceTimeStep(model_part); - - # - def FindNeighbours(self): - (self.neigh_finder).Execute(); - - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def PredictionStep(self, time): - - if(self.step > 2): - print("*************** second order prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - # performing a first order prediction of the fluid displacement - (self.PfemUtils).Predict(self.model_part) - (self.MeshMover).Execute(); - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - (self.ActOnWalls).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - # improve the prediction to reach second order - if(self.prediction_order == 2 and self.step > 2): - # lagrangian improvement of the correction - self.LagrangianCorrection() - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # verify if the mesh is suitable to go on calculations and eventually remesh - [inverted_elements, vol] = self.CheckForInvertedElements() - print("vol = ", vol) - if(inverted_elements): - self.Remesh() - print("********************************************* ") - print("**** PERFORMED EMERGENCY REMESH ************* ") - print("********************************************* ") - - self.CalculateProjections() - - # - def Remesh(self): - # clearing the sytem matrices as the connectivity will change - (self.fluid_solver).Clear() - print("fluid solver") - - # erase the nodes out of the bounding box - print("h_factor=", self.h_factor) - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - # (self.PfemUtils).MarkExcessivelyCloseNodes((self.model_part).Nodes,self.h_factor); - (self.EraseNodes).Execute(); - print("erase is executed") - - (self.neigh_finder).ClearNeighbours(); - print("neighbours are cleared") - - # erase all conditions and elements prior to remeshing - ((self.model_part).Elements).clear(); - ((self.model_part).Conditions).clear(); - print("elements are cleared") - - # remesh - if(self.domain_size == 2): - (self.Mesher).ReGenerateMesh("Fluid2DCoupled", "Condition2D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - else: -# (self.Mesher).ReGenerateMesh("Fluid3DCoupled","Condition3D",self.model_part,self.EraseNodes, self.alpha_shape) - (self.Mesher).ReGenerateMesh("Fluid3DCoupled", "Condition3D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - print(self.model_part) - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form); - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - self.substep = 0; - - # - def SolutionStep1(self): - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - normDx = Array3() - normDx[0] = 0.00 - normDx[1] = 0.00 - normDx[2] = 0.00 - is_converged = False - iteration = 0 - - # iterative solution of the velocity - while(is_converged == False and iteration < self.max_vel_its): - (self.fluid_solver).FractionalVelocityIteration(normDx); - is_converged = (self.fluid_solver).ConvergenceCheck(normDx, self.vel_toll); - iteration = iteration + 1 - - # - def LagrangianCorrection(self): - print("Lagrangian prediction") - - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - print("before lagrangian solution") - - normDx = Array3() - normDx[0] = 0.00 - normDx[1] = 0.00 - normDx[2] = 0.00 - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).FractionalVelocityIteration(normDx); - - is_converged = (self.fluid_solver).ConvergenceCheck(normDx, self.vel_toll); - - (self.lagrangian_tools).CalculateStep1DisplacementCorrection((self.model_part)) - print("after lagrangian solution") - - # deleting unnecessary memory -# (self.fluid_solver).Clear() - - return normDx - - # - # ALE solution of the fluid on the moving domain - def FluidSolutionStep(self): - (self.fluid_solver).ApplyFractionalVelocityFixity() - - if(self.step < self.time_order + 2): - print("IterativeSolve") -# self.PredictorCorrectorFluidSolutionStep() - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - - (self.fluid_solver).AssignInitialStepValues(); - print("adsdfsafafds") - (self.fluid_solver.IterativeSolve()) - print("qqqq") - - else: - if(self.predictor_corrector == False): - self.PureFractionalStepFluidSolutionStep() - else: - self.PredictorCorrectorFluidSolutionStep() - -# self.step = self.step + 1 - self.substep = self.substep + 1 - -# (self.fluid_solver).Clear() -# if(self.substep == self.mesh_every_nsteps): -# (self.fluid_solver).Clear() - # - def PureFractionalStepFluidSolutionStep(self): - print("PureFractionalStepFluidSolutionStep beginning") - self.SolutionStep1() - print("PureFractionalStepFluidSolutionStep after step1") - - (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - if(self.uzawa_term_is_active): - (self.fluid_solver).SolveStep2_Mp(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - # - # ALE solution of the fluid on the moving domain - def PredictorCorrectorFluidSolutionStep(self): - - print("PredictorCorrectorFluidSolutionStep beginning") - it = 1 - pressure_is_converged = False - while(pressure_is_converged == False and it <= self.max_press_its): - - self.SolutionStep1() - - dp = (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - if(self.uzawa_term_is_active): - (self.fluid_solver).SolveStep2_Mp(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - p_norm = (self.fluid_solver).SavePressureIteration() - - it = it + 1 - - ratio = 0.0 - if(p_norm > 1e-10): - ratio = dp / p_norm - print("********************* ", it, " ******", ratio, " **************") - if(ratio < self.press_toll): - pressure_is_converged = True - - # - # - # nodes in the inlet introduced and ALE acceleration calculated - def PostSolutionStep(self): - self.step = self.step + 1 - print("doing nothing in the post step") - # lagrangian fluid step - #(self.LagrangianInlet).Execute(); - - # calculate the spatial (ALE) acceleration -# if(self.domain_size == 2): -# (self.PfemUtils).CalculateSpatialALEAcceleration2D(self.model_part) -# else: -# (self.PfemUtils).CalculateSpatialALEAcceleration3D(self.model_part) - - # - def OutputStep(self, time, gid_io): -# if(time >= self.next_output_time): - if(time >= self.next_output_time): - self.next_output_time = self.next_output_time + self.output_time_increment; - - # writing mesh - gid_io.InitializeMesh(time); - gid_io.WriteNodeMesh((self.model_part).GetMesh()); - gid_io.WriteMesh((self.model_part).GetMesh()); - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(time, (self.model_part).GetMesh()); - gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); - gid_io.Flush() - gid_io.FinalizeResults() - -# file_name = self.output_name -# file_name = file_name + str(time) -# -# print "before changing name" -# gid_io.ChangeOutputName(file_name,GiDPostMode.GiD_PostBinary); -# print "name changed" -# my_mesh = (self.model_part).GetMesh() -# print my_mesh -# print self.model_part -# gid_io.WriteMesh((self.model_part).GetMesh(),self.domain_size,GiDPostMode.GiD_PostBinary); -# print "mesh written" -# gid_io.WriteNodalResults(NODAL_AREA, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL_TO_WALL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_LAGRANGIAN_INLET, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NODAL_H, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(MESH_VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(ACCELERATION, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(BODY_FORCE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESS_PROJ, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(CONV_PROJ, (self.model_part).Nodes, time, 0); -# -# print "results finished" -# gid_io.Flush() -# gid_io.CloseResultFile(); - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def EulerianLagrangianPredictionStep(self, time): - - print(self.step) - if(self.step > 2): - print("*************** eulerian-lagrangian prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - # performing a first order prediction of the fluid displacement - # without moving the mesh - (self.PfemUtils).Predict(self.model_part) - - # lagrangian improvement of the displacements - if(self.step > 2): - # copying the velocity to the mesh_velocity to set to zero the convective part) - (self.utilities).CopyVectorVar(VELOCITY, MESH_VELOCITY, (self.model_part).Nodes); - self.LagrangianCorrection() - - print("ln522") - (self.MeshMover).Execute(); - - print("ln525") - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - print("ln529") - (self.ActOnWalls).Execute(); - - print("ln 532") - (self.MeshMover).Execute(); - - print("ln529") - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - self.CalculateProjections() - - # - def CalculateProjections(self): - (self.PfemUtils).CalculateNodalMass(self.model_part, self.domain_size); - (self.fluid_solver).SolveStep3() - print("Projections were calculated") - - -# -# in this step the node position is predicted, the mesh is regenerated -# and the boundary conditions are imposed -# def PredictionStep(self,time): -# domain_size = self.domain_size -# -# calculate normals -# conditions = (self.model_part).Conditions -# (self.NormalTools).CalculateOnSimplex(conditions,domain_size) -# (self.NormalToWall).CalculateNormalToWall(conditions,domain_size) -# -# performing a first order prediction of the fluid displacement -# print "****************************" , self.prediction_order -# if( self.prediction_order == 12): -# (self.PfemUtils).Predict(self.model_part) -# (self.utilities).SetToZero_VectorVar(MESH_VELOCITY,(self.model_part).Nodes); -# if(self.step > 2): -# print "eulerian second order prediction" -# self.LagrangianCorrection() -# elif( self.prediction_order == 2): -# print "second order prediction" -# (self.PfemUtils).QuasiLagrangianMove(self.model_part) -# if(self.step > 2): -# -# (self.PfemUtils).Predict(self.model_part) -# (self.MeshMover).Execute(); -# -# calculating projections on the updated mesh position -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# if(self.step > 2): -# self.LagrangianCorrection() -# elif( self.prediction_order == 1): -# print "first order prediction" -# (self.PfemUtils).Predict(self.model_part) -# else: -# print "zeroth order prediction - no motion!!" -# -# (self.MeshMover).Execute(); -# -# (self.PfemUtils).MoveLonelyNodes(self.model_part) -# (self.MeshMover).Execute(); -# -# -# ensure that no node gets too close to the walls -# (self.ActOnWalls).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# smooth the final position of the nodes to homogeneize the mesh distribution -# (self.CoordinateSmoother).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# calculating projections on the updated mesh -# if(self.step > 2): -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# print "pfem_solver_ale line 262" -# print self.model_part -# -# regenerate the mesh -# print self.substep -# self.Remesh() - - - - -# -# if(self.correct_volume == True): -# calculate the new volume (after moving and alpha shape) -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# correct the volume to cure the volume loss -# (self.VolumeCorrectionTools).CorrectVolume(self.originalvolume, vol, (self.model_part).Nodes) -# (self.MeshMover).Execute(); diff --git a/applications/PFEMapplication/python_scripts/pfem_solver_ale_edge_swapping.py b/applications/PFEMapplication/python_scripts/pfem_solver_ale_edge_swapping.py deleted file mode 100644 index c3242c4297f8..000000000000 --- a/applications/PFEMapplication/python_scripts/pfem_solver_ale_edge_swapping.py +++ /dev/null @@ -1,771 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * -import time - - -def AddVariables(model_part): - model_part.AddNodalSolutionStepVariable(NORMAL) - model_part.AddNodalSolutionStepVariable(NORMAL_TO_WALL) - model_part.AddNodalSolutionStepVariable(DISPLACEMENT) - model_part.AddNodalSolutionStepVariable(VELOCITY) - model_part.AddNodalSolutionStepVariable(FRACT_VEL); - model_part.AddNodalSolutionStepVariable(MESH_VELOCITY); - model_part.AddNodalSolutionStepVariable(PRESSURE); - model_part.AddNodalSolutionStepVariable(PRESSURE_OLD_IT); - model_part.AddNodalSolutionStepVariable(PRESS_PROJ); - model_part.AddNodalSolutionStepVariable(CONV_PROJ); -# model_part.AddNodalSolutionStepVariable(NODAL_AREA); - model_part.AddNodalSolutionStepVariable(NODAL_MASS); - model_part.AddNodalSolutionStepVariable(BODY_FORCE); - model_part.AddNodalSolutionStepVariable(DENSITY); - model_part.AddNodalSolutionStepVariable(VISCOSITY); - model_part.AddNodalSolutionStepVariable(IS_STRUCTURE); - model_part.AddNodalSolutionStepVariable(IS_BOUNDARY); - model_part.AddNodalSolutionStepVariable(IS_FREE_SURFACE); - model_part.AddNodalSolutionStepVariable(IS_FLUID); - model_part.AddNodalSolutionStepVariable(IS_INTERFACE); - model_part.AddNodalSolutionStepVariable(NODAL_H); - model_part.AddNodalSolutionStepVariable(ARRHENIUS); - model_part.AddNodalSolutionStepVariable(EXTERNAL_PRESSURE); - print("variables for the incompressible fluid solver added correctly") - - -def AddDofs(model_part): - for node in model_part.Nodes: - # adding dofs - node.AddDof(PRESSURE); - node.AddDof(FRACT_VEL_X); - node.AddDof(FRACT_VEL_Y); - node.AddDof(FRACT_VEL_Z); - node.AddDof(VELOCITY_X); - node.AddDof(VELOCITY_Y); - node.AddDof(VELOCITY_Z); - - node.AddDof(IS_STRUCTURE); - print("dofs for the incompressible fluid solver added correctly") - - -class PFEMSolver: - - def __init__(self, model_part, OuputName, box_corner1, box_corner2, domain_size): - - self.domain_size = domain_size - self.model_part = model_part - self.output_name = OuputName - self.pure_lagrangian = False - self.correct_volume = True - self.prediction_order = 2 - self.echo_level = 0 - - self.mesh_every_nsteps = 10; - self.substep = 0; - - if(domain_size == 2): - self.Mesher = EdgeSwapping2DModeler() - self.InitializeMesher = TriGenPFEMModeler() -# self.Mesher = TriGenModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 9, 18) - elif (domain_size == 3): - self.Mesher = TetGenPfemModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 20, 30) - - self.Hfinder = FindNodalHProcess(model_part); - self.ActOnWalls = ActOnWallsNodalProcess(model_part) - - self.add_nodes = True - self.remove_nodes = True - number_of_smoothing_loops = 20 - reduction_factor = 1.0 - self.CoordinateSmoother = CoordinateLaplacianSmootherProcess(model_part, number_of_smoothing_loops, reduction_factor); - - self.MeshMover = MoveMeshProcess(model_part); - self.EraseNodes = NodeEraseProcess(model_part); - - self.NormalTools = NormalCalculationUtils() - self.NormalToWall = NormalToWallCalculationUtils() - self.PfemUtils = PfemUtils() - - if(self.correct_volume): - self.VolumeCorrectionTools = VolumeCorrectionUtils() - - self.alpha_shape = 1.5 - - # saving the limits of the box (all the nodes external to this will be erased) - self.box_corner1 = box_corner1 - self.box_corner2 = box_corner2 - - # assignation of parameters to be used - self.vel_toll = 0.0001; - self.press_toll = 0.001; - self.max_vel_its = 7; - self.max_press_its = 3; - self.time_order = 1; - self.CalculateReactions = False; - self.ReformDofAtEachIteration = True; - self.CalculateNormDxFlag = True; - self.laplacian_form = 3; # 1 = laplacian, 2 = Discrete Laplacian; 3 = discrete laplacian + tau=dt - self.predictor_corrector = False; - self.smooth = True - self.h_factor = 0.2 # nodes closer than h_factor * H will be erased - - self.step = 0 - - self.displacement_correction_afterstep4 = False - - self.eulerian_lagrangian = True - - self.uzawa_term_is_active = False - - # aux variable - self.normDx = Array3() - self.total_remeshing_time = 0.00 - - # definition of the solvers - pDiagPrecond = DiagonalPreconditioner() - self.velocity_linear_solver = BICGSTABSolver(1e-6, 5000, pDiagPrecond) - -# pILUPrecond = ILU0Preconditioner() -# self.pressure_linear_solver = BICGSTABSolver(1e-3, 5000,pILUPrecond) - - pDiagPrecond = DiagonalPreconditioner() - self.pressure_linear_solver = BICGSTABSolver(1e-4, 5000, pDiagPrecond) - # self.pressure_linear_solver = TFQMRSolver(1e-9, 5000,pDiagPrecond) - # pressure_linear_solver = SkylineLUFactorizationSolver() - - self.projections_are_initialized = True; - - def EstimateDeltaTime(self, min_dt, max_dt): - return (self.PfemUtils).EstimateDeltaTime(min_dt, max_dt, self.model_part) - - def Initialize(self, DeltaTime, output_time_increment): - - print("Initializing PFEM solver") - - # finding nodal connectivity - (self.neigh_finder).Execute(); - - domain_size = self.domain_size - - # time increment for output - self.output_time_increment = output_time_increment - self.next_output_time = self.output_time_increment - - # prediction of the structural motion - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size); - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size); - - # calculating the Hmap after reading the gid mesh - (self.Hfinder).Execute() - - # identify the fluid nodes - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # erase the nodes out of the bounding box - print("bounding box limits") - print(self.box_corner1) - print(self.box_corner2) - - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); -# (self.EraseNodes).Execute(); - - print("before remeshing") - [inverted_elements, vol] = self.CheckForInvertedElements() - print(inverted_elements) - print(vol) - - # remesh - if(self.domain_size == 2): - (self.InitializeMesher).ReGenerateMesh("Fluid2D", "Condition2D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - else: - (self.InitializeMesher).ReGenerateMesh("Fluid3D", "Condition3D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - - print("after remeshing") - [inverted_elements, vol] = self.CheckForInvertedElements() - print(inverted_elements) - print(vol) - -# (self.Mesher).ReGenerateMesh(self.model_part,self.alpha_shape) - print("remeshing in initalize performed successfully") - - print("*************************************************************") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # initializing the tool to allow the lagrangian inlet - # self.LagrangianInlet = LagrangianInletProcess(self.model_part,DeltaTime); - - print("time order = ", self.time_order) - # initializing the fluid solver - print(self.vel_toll) -# self.fluid_solver = ResidualBasedFluidStrategyCoupled(self.model_part,self.velocity_linear_solver,self.pressure_linear_solver,self.CalculateReactions,self.ReformDofAtEachIteration,self.CalculateNormDxFlag,self.vel_toll,self.press_toll, self.max_vel_its,self.max_press_its, self.time_order,self.domain_size, self.laplacian_form, self.predictor_corrector) - self.fluid_solver = ResidualBasedFluidStrategy(self.model_part, self.velocity_linear_solver, self.pressure_linear_solver, self.CalculateReactions, self.ReformDofAtEachIteration, self.CalculateNormDxFlag, self.vel_toll, self.press_toll, self.max_vel_its, self.max_press_its, self.time_order, self.domain_size, self.laplacian_form, self.predictor_corrector) - (self.fluid_solver).SetEchoLevel(self.echo_level) - - # determine the original volume - if(self.correct_volume): - [inverted_elements, vol] = self.CheckForInvertedElements() - self.originalvolume = vol - - (self.lagrangian_tools) = LagrangianUtils() - (self.VariableUtils) = VariableUtils() - - self.utilities = VariableUtils() - - print("Intialize PFEM solver terminated") - - # - def Solve(self, time, gid_io): - self.FindNeighbours() - - if(self.eulerian_lagrangian): - print("SONO QUI") - self.EulerianLagrangianPredictionStep(time) - else: - print("SONO LI") - self.PredictionStep(time) - - print("ln257") - for node in self.model_part.Nodes: - if(node.X < 0.0): - errore - - self.FluidSolutionStep() - - self.PostSolutionStep() - print("ln269") - for node in self.model_part.Nodes: - if(node.X < 0.0): - errore - - self.OutputStep(time, gid_io) - - # - def CheckForInvertedElements(self): - volume = (self.PfemUtils).CalculateVolume(self.model_part, self.domain_size) - inverted_elements = False - if(volume < 0.0): - volume = - volume - inverted_elements = True - return [inverted_elements, volume] - - # - def ReduceTimeStep(self, model_part): - (self.PfemUtils).ReduceTimeStep(model_part); - - # - def FindNeighbours(self): - (self.neigh_finder).Execute(); - - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def PredictionStep(self, time): - - if(self.step > 2): - print("*************** second order prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - print("pfem_solver_ale line 257") - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - print("pfem_solver_ale line 259") - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - print("pfem_solver_ale line 261") - # performing a first order prediction of the fluid displacement - (self.PfemUtils).Predict(self.model_part) - (self.MeshMover).Execute(); - - print(" line 305") - for node in self.model_part.Nodes: - if(node.X < 0.0): - errore - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - - print(" line 314") - for node in self.model_part.Nodes: - if(node.X < 0.0): - errore - - for node in self.model_part.Nodes: - if(node.GetSolutionStepValue(IS_STRUCTURE) == 1): - print("Normal to wall: ", node.GetSolutionStepValue(NORMAL_TO_WALL)) - print("normal: ", node.GetSolutionStepValue(NORMAL)) - - (self.ActOnWalls).Execute(); - - print(" line 320") - for node in self.model_part.Nodes: - if(node.X < 0.0): - errore - (self.MeshMover).Execute(); - - print(" line 326") - for node in self.model_part.Nodes: - if(node.X < 0.0): - errore - - # remesh - self.Remesh() - print(self.model_part) - print(" line 335") - for node in self.model_part.Nodes: - if(node.X < 0.0): - errore - - # improve the prediction to reach second order - if(self.prediction_order == 2 and self.step > 2): - # lagrangian improvement of the correction - self.LagrangianCorrection() - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # verify if the mesh is suitable to go on calculations and eventually remesh - [inverted_elements, vol] = self.CheckForInvertedElements() - print("vol = ", vol) - if(inverted_elements): - self.Remesh() - print("********************************************* ") - print("**** PERFORMED EMERGENCY REMESH ************* ") - print("********************************************* ") - - self.CalculateProjections() - - # - def Remesh(self): - - # clearing the sytem matrices as the connectivity will change - (self.fluid_solver).Clear() - print("fluid solver") - - # erase the nodes out of the bounding box - print("h_factor=", self.h_factor) - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.PfemUtils).MarkExcessivelyCloseNodes((self.model_part).Nodes, self.h_factor); -# (self.EraseNodes).Execute(); - print("erase is executed") - - (self.neigh_finder).ClearNeighbours(); - print("neighbours are cleared") - - # erase all conditions and elements prior to remeshing -# ((self.model_part).Elements).clear(); -# ((self.model_part).Conditions).clear(); - print("elements are cleared") - - print("before remeshing") - [inverted_elements, vol] = self.CheckForInvertedElements() - print(inverted_elements) - print(vol) - - remeshing_start_time = time.time() - - # remesh - #(self.Mesher).ReGenerateMesh(self.model_part,self.alpha_shape) - if(self.domain_size == 2): - (self.Mesher).ReGenerateMesh("Fluid2D", "Condition2D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - else: - (self.Mesher).ReGenerateMesh("Fluid3D", "Condition3D", self.model_part, self.EraseNodes, self.remove_nodes, self.add_nodes, self.alpha_shape, self.h_factor) - - print("after remeshing") - remeshing_end_time = time.time() - - print("Remeshing time :", remeshing_end_time - remeshing_start_time) - self.total_remeshing_time += remeshing_end_time - remeshing_start_time - print("Total remeshing time :", self.total_remeshing_time) - - [inverted_elements, vol] = self.CheckForInvertedElements() - print(inverted_elements) - print(vol) - - print(self.model_part) - - print("a") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - print("b") - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form); - print("c") - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - print("d") - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - print("e") - - self.substep = 0; - - # - def SolutionStep1(self): - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - self.normDx[0] = 0.00 - self.normDx[1] = 0.00 - self.normDx[2] = 0.00 - is_converged = False - iteration = 0 - - # iterative solution of the velocity - while(is_converged == False and iteration < self.max_vel_its): - (self.fluid_solver).FractionalVelocityIteration(self.normDx); - is_converged = (self.fluid_solver).ConvergenceCheck(self.normDx, self.vel_toll); - iteration = iteration + 1 - - # - def LagrangianCorrection(self): - print("Lagrangian prediction") - - # step initialization for the fluid solution - (self.fluid_solver).ApplyFractionalVelocityFixity() - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - print("before lagrangian solution") - - self.normDx[0] = 0.00 - self.normDx[1] = 0.00 - self.normDx[2] = 0.00 - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).FractionalVelocityIteration(self.normDx); - - is_converged = (self.fluid_solver).ConvergenceCheck(self.normDx, self.vel_toll); - - (self.lagrangian_tools).CalculateStep1DisplacementCorrection((self.model_part)) - print("after lagrangian solution") - - # deleting unnecessary memory -# (self.fluid_solver).Clear() - - # return normDx - - # - # ALE solution of the fluid on the moving domain - def FluidSolutionStep(self): - (self.fluid_solver).ApplyFractionalVelocityFixity() - - if(self.step < self.time_order + 2): - print("IterativeSolve") -# self.PredictorCorrectorFluidSolutionStep() - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - - (self.fluid_solver).AssignInitialStepValues(); - print("adsdfsafafds") - (self.fluid_solver.IterativeSolve()) - print("qqqq") - - else: - if(self.predictor_corrector == False): - self.PureFractionalStepFluidSolutionStep() - else: - self.PredictorCorrectorFluidSolutionStep() - -# self.step = self.step + 1 - self.substep = self.substep + 1 - -# (self.fluid_solver).Clear() -# if(self.substep == self.mesh_every_nsteps): -# (self.fluid_solver).Clear() - # - def PureFractionalStepFluidSolutionStep(self): - print("PureFractionalStepFluidSolutionStep beginning") - self.SolutionStep1() - print("PureFractionalStepFluidSolutionStep after step1") - - (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - if(self.uzawa_term_is_active): - (self.fluid_solver).SolveStep2_Mp(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - # - # ALE solution of the fluid on the moving domain - def PredictorCorrectorFluidSolutionStep(self): - - print("PredictorCorrectorFluidSolutionStep beginning") - it = 1 - pressure_is_converged = False - while(pressure_is_converged == False and it <= self.max_press_its): - - self.SolutionStep1() - - dp = (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - if(self.uzawa_term_is_active): - (self.fluid_solver).SolveStep2_Mp(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - p_norm = (self.fluid_solver).SavePressureIteration() - - it = it + 1 - - ratio = 0.0 - if(p_norm > 1e-10): - ratio = dp / p_norm - print("********************* ", it, " ******", ratio, " **************") - if(ratio < self.press_toll): - pressure_is_converged = True - - # - # - # nodes in the inlet introduced and ALE acceleration calculated - def PostSolutionStep(self): - self.step = self.step + 1 - print("doing nothing in the post step") - # lagrangian fluid step - #(self.LagrangianInlet).Execute(); - - # calculate the spatial (ALE) acceleration -# if(self.domain_size == 2): -# (self.PfemUtils).CalculateSpatialALEAcceleration2D(self.model_part) -# else: -# (self.PfemUtils).CalculateSpatialALEAcceleration3D(self.model_part) - - # - def OutputStep(self, time, gid_io): -# if(time >= self.next_output_time): - if(time >= self.next_output_time): - self.next_output_time = self.next_output_time + self.output_time_increment; - - # writing mesh - gid_io.InitializeMesh(time); - gid_io.WriteNodeMesh((self.model_part).GetMesh()); - gid_io.WriteMesh((self.model_part).GetMesh()); - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(time, (self.model_part).GetMesh()); - - gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(VISCOSITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(DENSITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(MESH_VELOCITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(NORMAL, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(NORMAL_TO_WALL, (self.model_part).Nodes, time, 0); - - gid_io.Flush() - gid_io.FinalizeResults() - -# file_name = self.output_name -# file_name = file_name + str(time) -# -# print "before changing name" -# gid_io.ChangeOutputName(file_name,GiDPostMode.GiD_PostBinary); -# print "name changed" -# my_mesh = (self.model_part).GetMesh() -# print my_mesh -# print self.model_part -# gid_io.WriteMesh((self.model_part).GetMesh(),self.domain_size,GiDPostMode.GiD_PostBinary); -# print "mesh written" -# gid_io.WriteNodalResults(NODAL_AREA, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL_TO_WALL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_LAGRANGIAN_INLET, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NODAL_H, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(MESH_VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(ACCELERATION, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(BODY_FORCE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESS_PROJ, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(CONV_PROJ, (self.model_part).Nodes, time, 0); -# -# print "results finished" -# gid_io.Flush() -# gid_io.CloseResultFile(); - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def EulerianLagrangianPredictionStep(self, time): - - print(self.step) - if(self.step > 2): - print("*************** eulerian-lagrangian prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - print("ln566") - # performing a first order prediction of the fluid displacement - # without moving the mesh - (self.PfemUtils).Predict(self.model_part) - - print("ln571") - # lagrangian improvement of the displacements - if(self.step > 2): - # copying the velocity to the mesh_velocity to set to zero the convective part) - (self.utilities).CopyVectorVar(VELOCITY, MESH_VELOCITY, (self.model_part).Nodes); - self.LagrangianCorrection() - - print("ln522") - (self.MeshMover).Execute(); - - print("ln525") - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - print("ln529") - (self.ActOnWalls).Execute(); - - print("ln 532") - (self.MeshMover).Execute(); - - print("ln529") - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - self.CalculateProjections() - - # - def CalculateProjections(self): - (self.PfemUtils).CalculateNodalMass(self.model_part, self.domain_size); - (self.fluid_solver).SolveStep3() - print("Projections were calculated") - - -# -# in this step the node position is predicted, the mesh is regenerated -# and the boundary conditions are imposed -# def PredictionStep(self,time): -# domain_size = self.domain_size -# -# calculate normals -# conditions = (self.model_part).Conditions -# (self.NormalTools).CalculateOnSimplex(conditions,domain_size) -# (self.NormalToWall).CalculateNormalToWall(conditions,domain_size) -# -# performing a first order prediction of the fluid displacement -# print "****************************" , self.prediction_order -# if( self.prediction_order == 12): -# (self.PfemUtils).Predict(self.model_part) -# (self.utilities).SetToZero_VectorVar(MESH_VELOCITY,(self.model_part).Nodes); -# if(self.step > 2): -# print "eulerian second order prediction" -# self.LagrangianCorrection() -# elif( self.prediction_order == 2): -# print "second order prediction" -# (self.PfemUtils).QuasiLagrangianMove(self.model_part) -# if(self.step > 2): -# -# (self.PfemUtils).Predict(self.model_part) -# (self.MeshMover).Execute(); -# -# calculating projections on the updated mesh position -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# if(self.step > 2): -# self.LagrangianCorrection() -# elif( self.prediction_order == 1): -# print "first order prediction" -# (self.PfemUtils).Predict(self.model_part) -# else: -# print "zeroth order prediction - no motion!!" -# -# (self.MeshMover).Execute(); -# -# (self.PfemUtils).MoveLonelyNodes(self.model_part) -# (self.MeshMover).Execute(); -# -# -# ensure that no node gets too close to the walls -# (self.ActOnWalls).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# smooth the final position of the nodes to homogeneize the mesh distribution -# (self.CoordinateSmoother).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# calculating projections on the updated mesh -# if(self.step > 2): -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# print "pfem_solver_ale line 262" -# print self.model_part -# -# regenerate the mesh -# print self.substep -# self.Remesh() - - - - -# -# if(self.correct_volume == True): -# calculate the new volume (after moving and alpha shape) -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# correct the volume to cure the volume loss -# (self.VolumeCorrectionTools).CorrectVolume(self.originalvolume, vol, (self.model_part).Nodes) -# (self.MeshMover).Execute(); diff --git a/applications/PFEMapplication/python_scripts/pfem_solver_ale_pavel.py b/applications/PFEMapplication/python_scripts/pfem_solver_ale_pavel.py deleted file mode 100644 index 4904cec1bc2d..000000000000 --- a/applications/PFEMapplication/python_scripts/pfem_solver_ale_pavel.py +++ /dev/null @@ -1,663 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.ULFApplication import * - - -def AddVariables(model_part): - model_part.AddNodalSolutionStepVariable(NORMAL) - model_part.AddNodalSolutionStepVariable(NORMAL_TO_WALL) - model_part.AddNodalSolutionStepVariable(DISPLACEMENT) - model_part.AddNodalSolutionStepVariable(VELOCITY); - model_part.AddNodalSolutionStepVariable(FRACT_VEL); - model_part.AddNodalSolutionStepVariable(MESH_VELOCITY); - model_part.AddNodalSolutionStepVariable(PRESSURE); - model_part.AddNodalSolutionStepVariable(PRESSURE_OLD_IT); - model_part.AddNodalSolutionStepVariable(PRESS_PROJ); - model_part.AddNodalSolutionStepVariable(CONV_PROJ); -# model_part.AddNodalSolutionStepVariable(NODAL_AREA); - model_part.AddNodalSolutionStepVariable(NODAL_MASS); - model_part.AddNodalSolutionStepVariable(BODY_FORCE); - model_part.AddNodalSolutionStepVariable(DENSITY); - model_part.AddNodalSolutionStepVariable(VISCOSITY); - model_part.AddNodalSolutionStepVariable(IS_STRUCTURE); - model_part.AddNodalSolutionStepVariable(IS_BOUNDARY); - model_part.AddNodalSolutionStepVariable(IS_FREE_SURFACE); - model_part.AddNodalSolutionStepVariable(IS_FLUID); - model_part.AddNodalSolutionStepVariable(IS_INTERFACE); - model_part.AddNodalSolutionStepVariable(NODAL_H); - print("variables for the incompressible fluid solver added correctly") - - -def AddDofs(model_part): - for node in model_part.Nodes: - # adding dofs - node.AddDof(PRESSURE); - node.AddDof(FRACT_VEL_X); - node.AddDof(FRACT_VEL_Y); - node.AddDof(FRACT_VEL_Z); - node.AddDof(VELOCITY_X); - node.AddDof(VELOCITY_Y); - node.AddDof(VELOCITY_Z); - - node.AddDof(IS_STRUCTURE); - print("dofs for the incompressible fluid solver added correctly") - - -class PFEMSolver: - - def __init__(self, model_part, OuputName, box_corner1, box_corner2, domain_size): - - model_part.ProcessInfo.SetValue(DYNAMIC_TAU, 0.001); - - self.domain_size = domain_size - self.model_part = model_part - self.output_name = OuputName - self.pure_lagrangian = False - self.correct_volume = True - self.prediction_order = 2 - self.echo_level = 0 - - self.mesh_every_nsteps = 10; - self.substep = 0; - - if(domain_size == 2): - self.Mesher = TriGenModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 9, 18) - elif (domain_size == 3): - # self.Mesher = TetGenModeler() - self.Mesher = TetGenPfemModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 20, 30) - - self.Hfinder = FindNodalHProcess(model_part); - self.ActOnWalls = ActOnWallsNodalProcess(model_part) - - number_of_smoothing_loops = 20 - reduction_factor = 1.0 - self.CoordinateSmoother = CoordinateLaplacianSmootherProcess(model_part, number_of_smoothing_loops, reduction_factor); - - self.MeshMover = MoveMeshProcess(model_part); - self.EraseNodes = NodeEraseProcess(model_part); - - self.NormalTools = NormalCalculationUtils() - self.NormalToWall = NormalToWallCalculationUtils() - self.PfemUtils = PfemUtils() - - if(self.correct_volume): - self.VolumeCorrectionTools = VolumeCorrectionUtils() - - self.alpha_shape = 1.5 - - # saving the limits of the box (all the nodes external to this will be erased) - self.box_corner1 = box_corner1 - self.box_corner2 = box_corner2 - - # assignation of parameters to be used - self.vel_toll = 0.0001; - self.press_toll = 0.001; - self.max_vel_its = 7; - self.max_press_its = 3; - self.time_order = 1; - self.CalculateReactions = False; - self.ReformDofAtEachIteration = True; - self.CalculateNormDxFlag = True; - self.laplacian_form = 3; # 1 = laplacian, 2 = Discrete Laplacian; 3 = discrete laplacian + tau=dt - self.predictor_corrector = False; - self.smooth = True - self.h_factor = 0.2 # nodes closer than h_factor * H will be erased - - self.step = 0 - - self.displacement_correction_afterstep4 = False - - self.eulerian_lagrangian = True - - # definition of the solvers - pDiagPrecond = DiagonalPreconditioner() - self.velocity_linear_solver = BICGSTABSolver(1e-6, 5000, pDiagPrecond) - -# pILUPrecond = ILU0Preconditioner() -# self.pressure_linear_solver = BICGSTABSolver(1e-3, 5000,pILUPrecond) - - pDiagPrecond = DiagonalPreconditioner() - self.pressure_linear_solver = BICGSTABSolver(1e-4, 5000, pDiagPrecond) - # self.pressure_linear_solver = TFQMRSolver(1e-9, 5000,pDiagPrecond) - # pressure_linear_solver = SkylineLUFactorizationSolver() - - self.projections_are_initialized = True; - - def EstimateDeltaTime(self, min_dt, max_dt): - return (self.PfemUtils).EstimateDeltaTime(min_dt, max_dt, self.model_part) - - def Initialize(self, DeltaTime, output_time_increment): - - print("Initializing PFEM solver") - - # finding nodal connectivity - (self.neigh_finder).Execute(); - - domain_size = self.domain_size - - # time increment for output - self.output_time_increment = output_time_increment - self.next_output_time = self.output_time_increment - - # prediction of the structural motion - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size); - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size); - - # calculating the Hmap after reading the gid mesh - (self.Hfinder).Execute() - - # identify the fluid nodes - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # erase the nodes out of the bounding box - print("bounding box limits") - print(self.box_corner1) - print(self.box_corner2) - - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.EraseNodes).Execute(); - - # remesh - (self.Mesher).ReGenerateMeshPfem3Dinc(self.model_part, self.alpha_shape) - print("remeshing in initalize performed successfully") - - print("*************************************************************") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # initializing the tool to allow the lagrangian inlet - # self.LagrangianInlet = LagrangianInletProcess(self.model_part,DeltaTime); - - print("time order = ", self.time_order) - # initializing the fluid solver - print(self.vel_toll) -# self.fluid_solver = ResidualBasedFluidStrategyCoupled(self.model_part,self.velocity_linear_solver,self.pressure_linear_solver,self.CalculateReactions,self.ReformDofAtEachIteration,self.CalculateNormDxFlag,self.vel_toll,self.press_toll, self.max_vel_its,self.max_press_its, self.time_order,self.domain_size, self.laplacian_form, self.predictor_corrector) - self.fluid_solver = ResidualBasedFluidStrategy(self.model_part, self.velocity_linear_solver, self.pressure_linear_solver, self.CalculateReactions, self.ReformDofAtEachIteration, self.CalculateNormDxFlag, self.vel_toll, self.press_toll, self.max_vel_its, self.max_press_its, self.time_order, self.domain_size, self.laplacian_form, self.predictor_corrector) - (self.fluid_solver).SetEchoLevel(self.echo_level) - - # determine the original volume - if(self.correct_volume): - [inverted_elements, vol] = self.CheckForInvertedElements() - self.originalvolume = vol - - (self.lagrangian_tools) = LagrangianUtils() - (self.VariableUtils) = VariableUtils() - - self.utilities = VariableUtils() - - print("Intialize PFEM solver terminated") - - # - def Solve(self, time, gid_io): - self.FindNeighbours() - - if(self.eulerian_lagrangian): - print("SONO QUI") - self.EulerianLagrangianPredictionStep(time) - else: - print("SONO LI") - self.PredictionStep(time) - - self.FluidSolutionStep() - - self.PostSolutionStep() - - self.OutputStep(time, gid_io) - - # - def CheckForInvertedElements(self): - volume = (self.PfemUtils).CalculateVolume(self.model_part, self.domain_size) - inverted_elements = False - if(volume < 0.0): - volume = - volume - inverted_elements = True - return [inverted_elements, volume] - - # - def ReduceTimeStep(self, model_part): - (self.PfemUtils).ReduceTimeStep(model_part); - - # - def FindNeighbours(self): - (self.neigh_finder).Execute(); - - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def PredictionStep(self, time): - - if(self.step > 2): - print("*************** second order prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - # performing a first order prediction of the fluid displacement - (self.PfemUtils).Predict(self.model_part) - (self.MeshMover).Execute(); - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - (self.ActOnWalls).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - # improve the prediction to reach second order - if(self.prediction_order == 2 and self.step > 2): - # lagrangian improvement of the correction - self.LagrangianCorrection() - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # verify if the mesh is suitable to go on calculations and eventually remesh - [inverted_elements, vol] = self.CheckForInvertedElements() - print("vol = ", vol) - if(inverted_elements): - self.Remesh() - print("********************************************* ") - print("**** PERFORMED EMERGENCY REMESH ************* ") - print("********************************************* ") - - self.CalculateProjections() - - # - def Remesh(self): - # clearing the sytem matrices as the connectivity will change - (self.fluid_solver).Clear() - print("fluid solver") - - # erase the nodes out of the bounding box - print("h_factor=", self.h_factor) - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.PfemUtils).MarkExcessivelyCloseNodes((self.model_part).Nodes, self.h_factor); - (self.EraseNodes).Execute(); - print("erase is executed") - - (self.neigh_finder).ClearNeighbours(); - print("neighbours are cleared") - - # erase all conditions and elements prior to remeshing - ((self.model_part).Elements).clear(); - ((self.model_part).Conditions).clear(); - print("elements are cleared") - - # remesh - (self.Mesher).ReGenerateMeshPfem3Dinc(self.model_part, self.alpha_shape) - - print(self.model_part) - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form); - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - self.substep = 0; - - # - def SolutionStep1(self): - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - normDx = Array3() - normDx[0] = 0.00 - normDx[1] = 0.00 - normDx[2] = 0.00 - is_converged = False - iteration = 0 - - # iterative solution of the velocity - while(is_converged == False and iteration < self.max_vel_its): - (self.fluid_solver).FractionalVelocityIteration(normDx); - is_converged = (self.fluid_solver).ConvergenceCheck(normDx, self.vel_toll); - iteration = iteration + 1 - - # - def LagrangianCorrection(self): - print("Lagrangian prediction") - - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - print("before lagrangian solution") - - normDx = Array3() - normDx[0] = 0.00 - normDx[1] = 0.00 - normDx[2] = 0.00 - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).FractionalVelocityIteration(normDx); - - is_converged = (self.fluid_solver).ConvergenceCheck(normDx, self.vel_toll); - - (self.lagrangian_tools).CalculateStep1DisplacementCorrection((self.model_part)) - print("after lagrangian solution") - - # deleting unnecessary memory -# (self.fluid_solver).Clear() - - return normDx - - # - # ALE solution of the fluid on the moving domain - def FluidSolutionStep(self): - (self.fluid_solver).ApplyFractionalVelocityFixity() - - if(self.step < self.time_order + 2): - print("IterativeSolve") -# self.PredictorCorrectorFluidSolutionStep() - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - - (self.fluid_solver).AssignInitialStepValues(); - print("adsdfsafafds") - (self.fluid_solver.IterativeSolve()) - print("qqqq") - - else: - if(self.predictor_corrector == False): - self.PureFractionalStepFluidSolutionStep() - else: - self.PredictorCorrectorFluidSolutionStep() - -# self.step = self.step + 1 - self.substep = self.substep + 1 - -# (self.fluid_solver).Clear() -# if(self.substep == self.mesh_every_nsteps): -# (self.fluid_solver).Clear() - # - def PureFractionalStepFluidSolutionStep(self): - print("PureFractionalStepFluidSolutionStep beginning") - self.SolutionStep1() - print("PureFractionalStepFluidSolutionStep after step1") - - (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - # - # ALE solution of the fluid on the moving domain - def PredictorCorrectorFluidSolutionStep(self): - - print("PredictorCorrectorFluidSolutionStep beginning") - it = 1 - pressure_is_converged = False - while(pressure_is_converged == False and it <= self.max_press_its): - - self.SolutionStep1() - - dp = (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - p_norm = (self.fluid_solver).SavePressureIteration() - - it = it + 1 - - ratio = 0.0 - if(p_norm > 1e-10): - ratio = dp / p_norm - print("********************* ", it, " ******", ratio, " **************") - if(ratio < self.press_toll): - pressure_is_converged = True - - # - # - # nodes in the inlet introduced and ALE acceleration calculated - def PostSolutionStep(self): - self.step = self.step + 1 - print("doing nothing in the post step") - # lagrangian fluid step - #(self.LagrangianInlet).Execute(); - - # calculate the spatial (ALE) acceleration -# if(self.domain_size == 2): -# (self.PfemUtils).CalculateSpatialALEAcceleration2D(self.model_part) -# else: -# (self.PfemUtils).CalculateSpatialALEAcceleration3D(self.model_part) - - # - def OutputStep(self, time, gid_io): - if(time >= self.next_output_time): - self.next_output_time = self.next_output_time + self.output_time_increment; - - # writing mesh - gid_io.InitializeMesh(time); - gid_io.WriteNodeMesh((self.model_part).GetMesh()); - gid_io.WriteMesh((self.model_part).GetMesh()); - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(time, (self.model_part).GetMesh()); - gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(FORCE, (self.model_part).Nodes, time, 0); - gid_io.Flush() - gid_io.FinalizeResults() - -# file_name = self.output_name -# file_name = file_name + str(time) -# -# print "before changing name" -# gid_io.ChangeOutputName(file_name,GiDPostMode.GiD_PostBinary); -# print "name changed" -# my_mesh = (self.model_part).GetMesh() -# print my_mesh -# print self.model_part -# gid_io.WriteMesh((self.model_part).GetMesh(),self.domain_size,GiDPostMode.GiD_PostBinary); -# print "mesh written" -# gid_io.WriteNodalResults(NODAL_AREA, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NORMAL_TO_WALL, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_LAGRANGIAN_INLET, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(NODAL_H, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(MESH_VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(ACCELERATION, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(BODY_FORCE, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(PRESS_PROJ, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(CONV_PROJ, (self.model_part).Nodes, time, 0); -# -# print "results finished" -# gid_io.Flush() -# gid_io.CloseResultFile(); - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def EulerianLagrangianPredictionStep(self, time): - - print(self.step) - if(self.step > 2): - print("*************** eulerian-lagrangian prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - # performing a first order prediction of the fluid displacement - # without moving the mesh - (self.PfemUtils).Predict(self.model_part) - - # lagrangian improvement of the displacements - if(self.step > 2): - # copying the velocity to the mesh_velocity to set to zero the convective part) - (self.utilities).CopyVectorVar(VELOCITY, MESH_VELOCITY, (self.model_part).Nodes); - self.LagrangianCorrection() - - print("ln522") - (self.MeshMover).Execute(); - - print("ln525") - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - print("ln529") - (self.ActOnWalls).Execute(); - - print("ln 532") - (self.MeshMover).Execute(); - - print("ln529") - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - self.CalculateProjections() - - # - def CalculateProjections(self): - (self.PfemUtils).CalculateNodalMass(self.model_part, self.domain_size); - (self.fluid_solver).SolveStep3() - print("Projections were calculated") - - -# -# in this step the node position is predicted, the mesh is regenerated -# and the boundary conditions are imposed -# def PredictionStep(self,time): -# domain_size = self.domain_size -# -# calculate normals -# conditions = (self.model_part).Conditions -# (self.NormalTools).CalculateOnSimplex(conditions,domain_size) -# (self.NormalToWall).CalculateNormalToWall(conditions,domain_size) -# -# performing a first order prediction of the fluid displacement -# print "****************************" , self.prediction_order -# if( self.prediction_order == 12): -# (self.PfemUtils).Predict(self.model_part) -# (self.utilities).SetToZero_VectorVar(MESH_VELOCITY,(self.model_part).Nodes); -# if(self.step > 2): -# print "eulerian second order prediction" -# self.LagrangianCorrection() -# elif( self.prediction_order == 2): -# print "second order prediction" -# (self.PfemUtils).QuasiLagrangianMove(self.model_part) -# if(self.step > 2): -# -# (self.PfemUtils).Predict(self.model_part) -# (self.MeshMover).Execute(); -# -# calculating projections on the updated mesh position -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# if(self.step > 2): -# self.LagrangianCorrection() -# elif( self.prediction_order == 1): -# print "first order prediction" -# (self.PfemUtils).Predict(self.model_part) -# else: -# print "zeroth order prediction - no motion!!" -# -# (self.MeshMover).Execute(); -# -# (self.PfemUtils).MoveLonelyNodes(self.model_part) -# (self.MeshMover).Execute(); -# -# -# ensure that no node gets too close to the walls -# (self.ActOnWalls).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# smooth the final position of the nodes to homogeneize the mesh distribution -# (self.CoordinateSmoother).Execute(); -# -# move the mesh -# (self.MeshMover).Execute(); -# -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# calculating projections on the updated mesh -# if(self.step > 2): -# (self.utilities).CopyVectorVar(VELOCITY,FRACT_VEL,(self.model_part).Nodes); -# (self.PfemUtils).CalculateNodalArea(self.model_part,self.domain_size); -# (self.fluid_solver).ActOnLonelyNodes(); -# (self.fluid_solver).SolveStep3() -# -# print "pfem_solver_ale line 262" -# print self.model_part -# -# regenerate the mesh -# print self.substep -# self.Remesh() - - - - -# -# if(self.correct_volume == True): -# calculate the new volume (after moving and alpha shape) -# [inverted_elements,vol] = self.CheckForInvertedElements() -# -# correct the volume to cure the volume loss -# (self.VolumeCorrectionTools).CorrectVolume(self.originalvolume, vol, (self.model_part).Nodes) -# (self.MeshMover).Execute(); diff --git a/applications/PFEMapplication/python_scripts/pfem_solver_ale_rigidbody.py b/applications/PFEMapplication/python_scripts/pfem_solver_ale_rigidbody.py deleted file mode 100644 index 510654c2f0a7..000000000000 --- a/applications/PFEMapplication/python_scripts/pfem_solver_ale_rigidbody.py +++ /dev/null @@ -1,606 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.FSIApplication import * - - -def AddVariables(model_part): - model_part.AddNodalSolutionStepVariable(NORMAL) - model_part.AddNodalSolutionStepVariable(NORMAL_TO_WALL) - model_part.AddNodalSolutionStepVariable(DISPLACEMENT) - model_part.AddNodalSolutionStepVariable(VELOCITY); - model_part.AddNodalSolutionStepVariable(FRACT_VEL); - model_part.AddNodalSolutionStepVariable(MESH_VELOCITY); - model_part.AddNodalSolutionStepVariable(PRESSURE); - model_part.AddNodalSolutionStepVariable(PRESSURE_OLD_IT); - model_part.AddNodalSolutionStepVariable(PRESS_PROJ); - model_part.AddNodalSolutionStepVariable(CONV_PROJ); - model_part.AddNodalSolutionStepVariable(NODAL_MASS); - model_part.AddNodalSolutionStepVariable(BODY_FORCE); - model_part.AddNodalSolutionStepVariable(DENSITY); - model_part.AddNodalSolutionStepVariable(VISCOSITY); - model_part.AddNodalSolutionStepVariable(IS_STRUCTURE); - model_part.AddNodalSolutionStepVariable(IS_BOUNDARY); - model_part.AddNodalSolutionStepVariable(IS_FREE_SURFACE); - model_part.AddNodalSolutionStepVariable(IS_FLUID); - model_part.AddNodalSolutionStepVariable(IS_INTERFACE); - model_part.AddNodalSolutionStepVariable(NODAL_H); - - model_part.AddNodalSolutionStepVariable(FORCE); - - model_part.AddNodalSolutionStepVariable(RELAXED_DISP); - - print("variables for the incompressible fluid solver added correctly") - - -def AddDofs(model_part): - for node in model_part.Nodes: - # adding dofs - node.AddDof(PRESSURE); - node.AddDof(FRACT_VEL_X); - node.AddDof(FRACT_VEL_Y); - node.AddDof(FRACT_VEL_Z); - node.AddDof(VELOCITY_X); - node.AddDof(VELOCITY_Y); - node.AddDof(VELOCITY_Z); - - node.AddDof(IS_STRUCTURE); - print("dofs for the incompressible fluid solver added correctly") - - -class PFEMSolver: - - def __init__(self, model_part, OuputName, box_corner1, box_corner2, domain_size, structural_solver, structure_model_part): - - self.domain_size = domain_size - self.model_part = model_part - self.output_name = OuputName - self.pure_lagrangian = False - self.correct_volume = True - self.prediction_order = 2 - self.echo_level = 0 - - self.mesh_every_nsteps = 10; - self.substep = 0; - - if(domain_size == 2): - self.Mesher = TriGenModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 9, 18) - elif (domain_size == 3): - self.Mesher = TetGenModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 20, 30) - - self.Hfinder = FindNodalHProcess(model_part); - self.ActOnWalls = ActOnWallsNodalProcess(model_part) - - number_of_smoothing_loops = 20 - reduction_factor = 1.0 - self.CoordinateSmoother = CoordinateLaplacianSmootherProcess(model_part, number_of_smoothing_loops, reduction_factor); - - self.MeshMover = MoveMeshProcess(model_part); - self.EraseNodes = NodeEraseProcess(model_part); - - self.NormalTools = NormalCalculationUtils() - self.NormalToWall = NormalToWallCalculationUtils() - self.PfemUtils = PfemUtils() - - if(self.correct_volume): - self.VolumeCorrectionTools = VolumeCorrectionUtils() - - self.alpha_shape = 1.5 - - # saving the limits of the box (all the nodes external to this will be erased) - self.box_corner1 = box_corner1 - self.box_corner2 = box_corner2 - - # assignation of parameters to be used - self.vel_toll = 0.0001; - self.press_toll = 0.001; - self.max_vel_its = 7; - self.max_press_its = 3; - self.time_order = 1; - self.CalculateReactions = False; - self.ReformDofAtEachIteration = True; - self.CalculateNormDxFlag = True; - self.laplacian_form = 3; # 1 = laplacian, 2 = Discrete Laplacian; 3 = discrete laplacian + tau=dt - self.predictor_corrector = False; - self.smooth = True - self.h_factor = 0.2 # nodes closer than h_factor * H will be erased - - self.step = 0 - - self.displacement_correction_afterstep4 = False - - self.eulerian_lagrangian = True - - # definition of the solvers - pDiagPrecond = DiagonalPreconditioner() - self.velocity_linear_solver = BICGSTABSolver(1e-6, 5000, pDiagPrecond) - -# pILUPrecond = ILU0Preconditioner() -# self.pressure_linear_solver = BICGSTABSolver(1e-3, 5000,pILUPrecond) - - pDiagPrecond = DiagonalPreconditioner() - self.pressure_linear_solver = BICGSTABSolver(1e-4, 5000, pDiagPrecond) - # self.pressure_linear_solver = TFQMRSolver(1e-9, 5000,pDiagPrecond) - # pressure_linear_solver = SkylineLUFactorizationSolver() - - self.projections_are_initialized = True; - - self.structure_model_part = structure_model_part - self.structural_solver = structural_solver; - - def EstimateDeltaTime(self, min_dt, max_dt): - return (self.PfemUtils).EstimateDeltaTime(min_dt, max_dt, self.model_part) - - def Initialize(self, DeltaTime, output_time_increment): - - print("Initializing PFEM solver") - - # finding nodal connectivity - (self.neigh_finder).Execute(); - - domain_size = self.domain_size - - # time increment for output - self.output_time_increment = output_time_increment - self.next_output_time = self.output_time_increment - - # prediction of the structural motion - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size); - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size); - - # calculating the Hmap after reading the gid mesh - (self.Hfinder).Execute() - - # identify the fluid nodes - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # erase the nodes out of the bounding box - print("bounding box limits") - print(self.box_corner1) - print(self.box_corner2) - - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.EraseNodes).Execute(); - - # remesh - (self.Mesher).ReGenerateMesh(self.model_part, self.alpha_shape) - print("remeshing in initalize performed successfully") - - print("*************************************************************") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - # initializing the tool to allow the lagrangian inlet - # self.LagrangianInlet = LagrangianInletProcess(self.model_part,DeltaTime); - - print("time order = ", self.time_order) - # initializing the fluid solver - print(self.vel_toll) -# self.fluid_solver = ResidualBasedFluidStrategyCoupled(self.model_part,self.velocity_linear_solver,self.pressure_linear_solver,self.CalculateReactions,self.ReformDofAtEachIteration,self.CalculateNormDxFlag,self.vel_toll,self.press_toll, self.max_vel_its,self.max_press_its, self.time_order,self.domain_size, self.laplacian_form, self.predictor_corrector) - self.fluid_solver = ResidualBasedFluidStrategy(self.model_part, self.velocity_linear_solver, self.pressure_linear_solver, self.CalculateReactions, self.ReformDofAtEachIteration, self.CalculateNormDxFlag, self.vel_toll, self.press_toll, self.max_vel_its, self.max_press_its, self.time_order, self.domain_size, self.laplacian_form, self.predictor_corrector) - (self.fluid_solver).SetEchoLevel(self.echo_level) - - # determine the original volume - if(self.correct_volume): - [inverted_elements, vol] = self.CheckForInvertedElements() - self.originalvolume = vol - - (self.lagrangian_tools) = LagrangianUtils() - (self.VariableUtils) = VariableUtils() - - self.utilities = VariableUtils() - - # utilities for fsi solution - self.utilities = VariableUtils() - self.fsi_utils = FSIUtils() - self.aitken_utils = AitkenUtils() - self.force_utils = CalculateForcesUtils(); - - # initialize the list of interface nodes - self.interface_structure_nodes = (self.utilities).SelectNodeList(IS_INTERFACE, 1.0, self.structure_model_part.Nodes) - self.interface_fluid_nodes = (self.utilities).SelectNodeList(IS_INTERFACE, 1.0, self.model_part.Nodes) - - print("Intialize PFEM solver terminated") - - # - def Solve(self, time, gid_io): - self.FindNeighbours() - - if(self.eulerian_lagrangian): - print("SONO QUI") - self.EulerianLagrangianPredictionStep(time) - else: - print("SONO LI") - self.PredictionStep(time) - - self.FluidSolutionStep() - - self.PostSolutionStep() - - self.OutputStep(time, gid_io) - - # - def CheckForInvertedElements(self): - volume = (self.PfemUtils).CalculateVolume(self.model_part, self.domain_size) - inverted_elements = False - if(volume < 0.0): - volume = - volume - inverted_elements = True - return [inverted_elements, volume] - - # - def ReduceTimeStep(self, model_part): - (self.PfemUtils).ReduceTimeStep(model_part); - - # - def FindNeighbours(self): - (self.neigh_finder).Execute(); - - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def PredictionStep(self, time): - - if(self.step > 2): - print("*************** second order prediction ***************") - domain_size = self.domain_size - - # structural prediction - (self.structural_solver).solver.perform_prediction = False - (self.structural_solver).Solve() - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - # performing a first order prediction of the fluid displacement - (self.PfemUtils).Predict(self.model_part) - (self.MeshMover).Execute(); - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - (self.ActOnWalls).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - # improve the prediction to reach second order - if(self.prediction_order == 2 and self.step > 2): - # lagrangian improvement of the correction - self.LagrangianCorrection() - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # verify if the mesh is suitable to go on calculations and eventually remesh - [inverted_elements, vol] = self.CheckForInvertedElements() - print("vol = ", vol) - if(inverted_elements): - self.Remesh() - print("********************************************* ") - print("**** PERFORMED EMERGENCY REMESH ************* ") - print("********************************************* ") - - self.CalculateProjections() - - # - def Remesh(self): - # clearing the sytem matrices as the connectivity will change - (self.fluid_solver).Clear() - print("fluid solver") - - # erase the nodes out of the bounding box - print("h_factor=", self.h_factor) - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.PfemUtils).MarkExcessivelyCloseNodes((self.model_part).Nodes, self.h_factor); - (self.EraseNodes).Execute(); - print("erase is executed") - - (self.neigh_finder).ClearNeighbours(); - print("neighbours are cleared") - - # erase all conditions and elements prior to remeshing - ((self.model_part).Elements).clear(); - ((self.model_part).Conditions).clear(); - print("elements are cleared") - - # remesh - (self.Mesher).ReGenerateMesh(self.model_part, self.alpha_shape) - - print(self.model_part) - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form); - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).ApplyMinimalPressureConditions(self.model_part); - - self.substep = 0; - - # - def SolutionStep1(self): - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - normDx = Array3() - normDx[0] = 0.00 - normDx[1] = 0.00 - normDx[2] = 0.00 - is_converged = False - iteration = 0 - - # iterative solution of the velocity - while(is_converged == False and iteration < self.max_vel_its): - (self.fluid_solver).FractionalVelocityIteration(normDx); - is_converged = (self.fluid_solver).ConvergenceCheck(normDx, self.vel_toll); - iteration = iteration + 1 - - # - def LagrangianCorrection(self): - print("Lagrangian prediction") - - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - (self.fluid_solver).AssignInitialStepValues(); - - print("before lagrangian solution") - - normDx = Array3() - normDx[0] = 0.00 - normDx[1] = 0.00 - normDx[2] = 0.00 - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).FractionalVelocityIteration(normDx); - - is_converged = (self.fluid_solver).ConvergenceCheck(normDx, self.vel_toll); - - (self.lagrangian_tools).CalculateStep1DisplacementCorrection((self.model_part)) - print("after lagrangian solution") - - # deleting unnecessary memory -# (self.fluid_solver).Clear() - - return normDx - - # - # ALE solution of the fluid on the moving domain - def FluidSolutionStep(self): - (self.fluid_solver).ApplyFractionalVelocityFixity() - - if(self.step < self.time_order + 2): - print("IterativeSolve") -# self.PredictorCorrectorFluidSolutionStep() - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step, self.projections_are_initialized); - self.projections_are_initialized = True; - - (self.fluid_solver).AssignInitialStepValues(); - print("adsdfsafafds") - (self.fluid_solver.IterativeSolve()) - print("qqqq") - - else: - if(self.predictor_corrector == False): - self.PureFractionalStepFluidSolutionStep() - else: - self.PredictorCorrectorFluidSolutionStep() - -# self.step = self.step + 1 - self.substep = self.substep + 1 - -# (self.fluid_solver).Clear() -# if(self.substep == self.mesh_every_nsteps): -# (self.fluid_solver).Clear() - # - def PureFractionalStepFluidSolutionStep(self): - print("PureFractionalStepFluidSolutionStep beginning") - self.SolutionStep1() - - self.max_coupled_its = 3 - - for i in range(0, self.max_coupled_its): - print("FSI iteration =", i) - - # pressure solution - dp = (self.fluid_solver).SolveStep2(); - print("ln439") - - if(self.domain_size == 2): - (self.force_utils).CalculateForces2D(self.model_part); - else: - (self.force_utils).CalculateForces3D(self.model_part); - print("ln442") - - # solve structure - (self.structural_solver).solver.perform_prediction = False - (self.structural_solver).Solve() - print("Structural Correction: OK") - - i = i + 1 - - omega = 1.0; # no relaxation - - print("omega = ", omega) - - (self.utilities).SaveVectorVar(DISPLACEMENT, DISPLACEMENT, self.interface_structure_nodes) - (self.utilities).SaveVectorVar(RELAXED_DISP, RELAXED_DISP, self.interface_structure_nodes) - - self.aitken_utils.ComputeRelaxedDisplacement(self.interface_structure_nodes, omega) - - (self.MeshMover).Execute(); - - # - # finalizing fluid solution and getting ready for the next step ###### - # update the projections - (self.fluid_solver).ActOnLonelyNodes(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - # prepare the pressure for the next iteration (overwrites the pressure at the old step) - (self.utilities).CopyVectorVar(VELOCITY, FRACT_VEL, (self.model_part).Nodes); - (self.fluid_solver).SavePressureIteration() - print("STEP FINISHED") - - # - # ALE solution of the fluid on the moving domain - def PredictorCorrectorFluidSolutionStep(self): - - print("PredictorCorrectorFluidSolutionStep beginning") - it = 1 - pressure_is_converged = False - while(pressure_is_converged == False and it <= self.max_press_its): - - self.SolutionStep1() - - dp = (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - (self.fluid_solver).SolveStep3(); - - if(self.displacement_correction_afterstep4): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - else: - (self.fluid_solver).SolveStep4(); - - p_norm = (self.fluid_solver).SavePressureIteration() - - it = it + 1 - - ratio = 0.0 - if(p_norm > 1e-10): - ratio = dp / p_norm - print("********************* ", it, " ******", ratio, " **************") - if(ratio < self.press_toll): - pressure_is_converged = True - - # - # - # nodes in the inlet introduced and ALE acceleration calculated - def PostSolutionStep(self): - self.step = self.step + 1 - print("doing nothing in the post step") - # lagrangian fluid step - #(self.LagrangianInlet).Execute(); - - # calculate the spatial (ALE) acceleration -# if(self.domain_size == 2): -# (self.PfemUtils).CalculateSpatialALEAcceleration2D(self.model_part) -# else: -# (self.PfemUtils).CalculateSpatialALEAcceleration3D(self.model_part) - - # - def OutputStep(self, time, gid_io): - if(time >= self.next_output_time): - self.next_output_time = self.next_output_time + self.output_time_increment; - - # writing mesh - gid_io.InitializeMesh(time); - gid_io.WriteNodeMesh((self.model_part).GetMesh()); - gid_io.WriteMesh((self.model_part).GetMesh()); - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(time, (self.model_part).GetMesh()); - gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); -# gid_io.WriteNodalResults(FORCE, (self.model_part).Nodes, time, 0); - gid_io.Flush() - gid_io.FinalizeResults() - - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def EulerianLagrangianPredictionStep(self, time): - - print(self.step) - if(self.step > 2): - print("*************** eulerian-lagrangian prediction ***************") - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - # performing a first order prediction of the fluid displacement - # without moving the mesh - (self.PfemUtils).Predict(self.model_part) - - # lagrangian improvement of the displacements - if(self.step > 2): - # copying the velocity to the mesh_velocity to set to zero the convective part) - (self.utilities).CopyVectorVar(VELOCITY, MESH_VELOCITY, (self.model_part).Nodes); - self.LagrangianCorrection() - - print("ln522") - (self.MeshMover).Execute(); - - print("ln525") - - # move free nodes and treat nodes close to the boundary - (self.PfemUtils).MoveLonelyNodes(self.model_part) - print("ln529") - (self.ActOnWalls).Execute(); - - print("ln 532") - (self.MeshMover).Execute(); - - print("ln529") - - # smooth the mesh position - if(self.smooth): - (self.CoordinateSmoother).Execute(); - (self.MeshMover).Execute(); - - # remesh - self.Remesh() - print(self.model_part) - - self.CalculateProjections() - - # - def CalculateProjections(self): - (self.PfemUtils).CalculateNodalMass(self.model_part, self.domain_size); - (self.fluid_solver).SolveStep3() - print("Projections were calculated") diff --git a/applications/PFEMapplication/python_scripts/pfem_solver_lagrangian.py b/applications/PFEMapplication/python_scripts/pfem_solver_lagrangian.py deleted file mode 100644 index 7419fa5034d6..000000000000 --- a/applications/PFEMapplication/python_scripts/pfem_solver_lagrangian.py +++ /dev/null @@ -1,373 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * - - -def AddVariables(model_part): - for node in model_part.Nodes: - # adding variables - -# node.GetSolutionStepValue(IS_LAGRANGIAN_INLET) - node.GetSolutionStepValue(IS_STRUCTURE) - node.GetSolutionStepValue(IS_BOUNDARY) - node.GetSolutionStepValue(IS_FREE_SURFACE) - node.GetSolutionStepValue(NODAL_H) - - node.GetSolutionStepValue(IS_FLUID) - - node.GetSolutionStepValue(NORMAL) - node.GetSolutionStepValue(NORMAL_TO_WALL) - - node.GetSolutionStepValue(ACCELERATION) - node.GetSolutionStepValue(VELOCITY) - node.GetSolutionStepValue(DISPLACEMENT) - node.GetSolutionStepValue(FRACT_VEL) - node.GetSolutionStepValue(MESH_VELOCITY) - node.GetSolutionStepValue(PRESSURE) - node.GetSolutionStepValue(PRESSURE, 1) - node.GetSolutionStepValue(PRESS_PROJ) - node.GetSolutionStepValue(CONV_PROJ) - node.GetSolutionStepValue(NODAL_AREA) - - # adding dofs - node.AddDof(PRESSURE) - node.AddDof(FRACT_VEL_X) - node.AddDof(FRACT_VEL_Y) - node.AddDof(FRACT_VEL_Z) - node.AddDof(VELOCITY_X) - node.AddDof(VELOCITY_Y) - node.AddDof(VELOCITY_Z) - - print("variables for the incompressible fluid solver added correctly") - - -class PFEMSolver: - - def __init__(self, model_part, OuputName, box_corner1, box_corner2, domain_size): - - model_part.ProcessInfo.SetValue(DYNAMIC_TAU, 0.001) - - self.domain_size = domain_size - self.model_part = model_part - self.output_name = OuputName - self.pure_lagrangian = True - self.close_result_file = True - - if(domain_size == 2): - self.Mesher = TriGenModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 9, 18) - elif (domain_size == 3): - self.Mesher = TetGenModeler() - self.neigh_finder = FindNodalNeighboursProcess(model_part, 20, 30) - - self.Hfinder = FindNodalHProcess(model_part) - self.ActOnWalls = ActOnWallsNodalProcess(model_part) - - number_of_smoothing_loops = 20 - self.CoordinateSmoother = CoordinateLaplacianSmootherProcess(model_part, number_of_smoothing_loops) - - self.MeshMover = MoveMeshProcess(model_part) - self.EraseNodes = NodeEraseProcess(model_part) - - self.NormalTools = NormalCalculationUtils() - self.NormalToWall = NormalToWallCalculationUtils() - self.PfemUtils = PfemUtils() - - self.VolumeCorrectionTools = VolumeCorrectionUtils() - self.oldvol = 0.0 - - self.alpha_shape = 1.5 - - # saving the limits of the box (all the nodes external to this will be erased) - self.box_corner1 = box_corner1 - self.box_corner2 = box_corner2 - - # assignation of parameters to be used - self.vel_toll = 0.0001 - self.press_toll = 0.001; - self.max_vel_its = 7; - self.max_press_its = 3; - self.time_order = 1; - self.CalculateReactions = False; - self.ReformDofAtEachIteration = True; - self.CalculateNormDxFlag = True; - self.laplacian_form = 2; # 1 = laplacian, 2 = Discrete Laplacian - self.predictor_corrector = False; # do not set it to true!!!! - self.smooth = True - - self.step = 0 - - # definition of the solvers - pDiagPrecond = DiagonalPreconditioner() - self.velocity_linear_solver = BICGSTABSolver(1e-6, 5000, pDiagPrecond) - - pILUPrecond = ILU0Preconditioner() - self.pressure_linear_solver = BICGSTABSolver(1e-3, 5000, pILUPrecond) - # self.pressure_linear_solver = TFQMRSolver(1e-9, 5000,pDiagPrecond) - # pressure_linear_solver = SkylineLUFactorizationSolver() - - def EstimateDeltaTime(self, min_dt, max_dt): - return (self.PfemUtils).EstimateDeltaTime(min_dt, max_dt, self.model_part) - - def Initialize(self, DeltaTime, output_time_increment): - - print("Initializing PFEM solver") - - # finding nodal connectivity - (self.neigh_finder).Execute(); - - domain_size = self.domain_size - - # time increment for output - self.output_time_increment = output_time_increment - self.next_output_time = self.output_time_increment - - # prediction of the structural motion - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size); - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size); - - # calculating the Hmap after reading the gid mesh - (self.Hfinder).Execute() - - # erase the nodes out of the bounding box - print("bounding box limits") - print(self.box_corner1) - print(self.box_corner2) - (self.PfemUtils).IdentifyFluidNodes(self.model_part); - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.EraseNodes).Execute(); - - # remesh - (self.Mesher).ReGenerateMesh(self.model_part, self.alpha_shape) - - print("*************************************************************") - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form) - - # initializing the tool to allow the lagrangian inlet - # self.LagrangianInlet = LagrangianInletProcess(self.model_part,DeltaTime); - - # initializing the fluid solver -# self.fluid_solver = ResidualBasedFluidStrategyCoupled(self.model_part,self.velocity_linear_solver,self.pressure_linear_solver,self.CalculateReactions,self.ReformDofAtEachIteration,self.CalculateNormDxFlag,self.vel_toll,self.press_toll, self.max_vel_its,self.max_press_its, self.time_order,self.domain_size, self.laplacian_form, self.predictor_corrector) - self.fluid_solver = ResidualBasedFluidStrategy(self.model_part, self.velocity_linear_solver, self.pressure_linear_solver, self.CalculateReactions, self.ReformDofAtEachIteration, self.CalculateNormDxFlag, self.vel_toll, self.press_toll, self.max_vel_its, self.max_press_its, self.time_order, self.domain_size, self.laplacian_form, self.predictor_corrector) - (self.fluid_solver).SetEchoLevel(0) - - (self.lagrangian_tools) = LagrangianUtils() - (self.VariableUtils) = VariableUtils() - - print("Intialize PFEM solver terminated") - - # - def Solve(self, time, gid_io): - - self.PredictionStep(time) - self.FluidSolutionStep() - - self.PostSolutionStep() - - self.OutputStep(time, gid_io) - - # - def SolutionStep1(self): - # step initialization for the fluid solution - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step); - (self.fluid_solver).AssignInitialStepValues(); - - normDx = Array3() - normDx[0] = 0.00 - normDx[1] = 0.00 - normDx[2] = 0.00 - is_converged = False - iteration = 0 - - while( is_converged == False and iteration < self.max_vel_its): - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).FractionalVelocityIteration(normDx); - (self.lagrangian_tools).CalculateStep1DisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - is_converged = (self.fluid_solver).ConvergenceCheck(normDx, self.vel_toll); - iteration = iteration + 1 - - # - # in this step the node position is predicted, the mesh is regenerated - # and the boundary conditions are imposed - def PredictionStep(self, time): - domain_size = self.domain_size - - # calculate normals - conditions = (self.model_part).Conditions - (self.NormalTools).CalculateOnSimplex(conditions, domain_size) - (self.NormalToWall).CalculateNormalToWall(conditions, domain_size) - - # lagrangian_prediction - (self.lagrangian_tools).ExplicitLagrangianPrediction((self.model_part)) - - (self.PfemUtils).MoveLonelyNodes(self.model_part) - - (self.MeshMover).Execute(); - - # ensure that no node gets too close to the walls - (self.ActOnWalls).Execute(); - - # move the mesh - (self.MeshMover).Execute(); - - if(self.pure_lagrangian == False): - - # ensure that no node gets too close to the walls - (self.ActOnWalls).Execute(); - - # move the mesh - (self.MeshMover).Execute(); - - # smooth the final position of the nodes to homogeneize the mesh distribution - if(self.smooth): - (self.CoordinateSmoother).Execute(); - - # move the mesh - (self.MeshMover).Execute(); - - # regenerate the mesh - self.Remesh() - - # - def Remesh(self): - # erase all conditions and elements prior to remeshing - ((self.model_part).Elements).clear(); - ((self.model_part).Conditions).clear(); - - # erase the nodes out of the bounding box - (self.PfemUtils).MarkOuterNodes(self.box_corner1, self.box_corner2, (self.model_part).Nodes); - (self.EraseNodes).Execute(); - - # remesh - (self.Mesher).ReGenerateMesh(self.model_part, self.alpha_shape) - - print(self.model_part) - - # recalculating neighbours - (self.neigh_finder).Execute(); - - # apply the boundary conditions as needed - (self.PfemUtils).ApplyBoundaryConditions(self.model_part, self.laplacian_form); - - # - # ALE solution of the fluid on the moving domain - def FluidSolutionStep(self): - - # solve the fluid problem - (self.fluid_solver).ApplyFractionalVelocityFixity() - - if(self.step < self.time_order + 1): - (self.fluid_solver).InitializeFractionalStep(self.step, self.time_order); - (self.fluid_solver).InitializeProjections(self.step); - (self.fluid_solver).AssignInitialStepValues(); - (self.fluid_solver.IterativeSolve()) - else: - if(self.predictor_corrector == False): - self.PureFractionalStepFluidSolutionStep() - else: - self.PredictorCorrectorFluidSolutionStep() - - self.step = self.step + 1 - - (self.fluid_solver).Clear() - - # - def PureFractionalStepFluidSolutionStep(self): - self.SolutionStep1() - - (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - (self.fluid_solver).SolveStep3(); - - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - - # - # ALE solution of the fluid on the moving domain - def PredictorCorrectorFluidSolutionStep(self): - - it = 1 - pressure_is_converged = False - while(pressure_is_converged == False and it <= self.max_press_its): - -# inverted_elements = False -# vol = (self.PfemUtils).CalculateVolume(self.model_part,self.domain_size,inverted_elements) -# print vol -# if(inverted_elements == True): -# print "**********************************************************" -# print "emergency remesh" -# print "**********************************************************" -# self.Remesh() - - self.SolutionStep1() - - dp = (self.fluid_solver).SolveStep2(); - (self.fluid_solver).ActOnLonelyNodes(); - (self.fluid_solver).SolveStep3(); - - (self.VariableUtils).SaveVectorVar(FRACT_VEL, VAUX, (self.model_part).Nodes) - (self.fluid_solver).SolveStep4(); - (self.lagrangian_tools).CalculateFinalDisplacementCorrection((self.model_part)) - (self.MeshMover).Execute(); - - p_norm = (self.fluid_solver).SavePressureIteration() - - it = it + 1 - print("********************* ", it, " ******", dp / p_norm, " **************") - if(dp / p_norm < self.press_toll): - pressure_is_converged = True - - self.step = self.step + 1 - - (self.fluid_solver).Clear() - - # - # nodes in the inlet introduced and ALE acceleration calculated - def PostSolutionStep(self): - print("doing nothing in the post solution step") - - # estimate error - # error_estimator.Execute(); - - # lagrangian fluid step - # (self.LagrangianInlet).Execute(); - - # - def OutputStep(self, time, gid_io): - if(time >= self.next_output_time): - self.next_output_time = self.next_output_time + self.output_time_increment; - - file_name = self.output_name - file_name = file_name + str(time) - - gid_io.ChangeOutputName(file_name, GiDPostMode.GiD_PostBinary); - gid_io.WriteMesh((self.model_part).GetMesh(), self.domain_size, GiDPostMode.GiD_PostBinary); - - gid_io.WriteNodalResults(NODAL_AREA, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(NORMAL, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(NORMAL_TO_WALL, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(PRESSURE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FREE_SURFACE, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_BOUNDARY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_STRUCTURE, (self.model_part).Nodes, time, 0); - # gid_io.WriteNodalResults(IS_LAGRANGIAN_INLET, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(IS_FLUID, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(VELOCITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(MESH_VELOCITY, (self.model_part).Nodes, time, 0); - gid_io.WriteNodalResults(ACCELERATION, (self.model_part).Nodes, time, 0); - - if(self.close_result_file): - gid_io.Flush() - gid_io.CloseResultFile(); diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette2dNonNewt.py b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette2dNonNewt.py deleted file mode 100755 index eddfb11c45e5..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette2dNonNewt.py +++ /dev/null @@ -1,226 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import fluid_only_var - -# -# -# setting the domain size for the problem to be solved -domain_size = fluid_only_var.domain_size - -# -# -# ATTENTION: here the order is important - -# including kratos path -kratos_path = '../../../../' # kratos_root -kratos_benchmarking_path = '../../../../benchmarking' # kratos_root/benchmarking -import sys -sys.path.append(kratos_path) -sys.path.append(kratos_benchmarking_path) -import benchmarking - -# importing Kratos main library -from KratosMultiphysics import * - - -# from now on the order is not anymore crucial -# -# -from KratosMultiphysics.IncompressibleFluidApplication import * -# from KratosMultiphysics.ExternalSolversApplication import * - - -def NodeFinder(node_list, X, Y, Z): - for node in node_list: - if((node.X - X) ** 2 + (node.Y - Y) ** 2 + (node.Z -Z)**2 < .0001): - return node - - -def BenchmarkCheck(time, node1, node2): - benchmarking.Output(time, "Time") -# print "IIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIII" - benchmarking.Output(node1.GetSolutionStepValue(VELOCITY_X), "Node 1 velocity_x", 0.01, .00001) - benchmarking.Output(node2.GetSolutionStepValue(VELOCITY_X), "Node 2 velocity_x", 0.01, .00001) - - -# defining a model part for the fluid and one for the structure -fluid_model_part = ModelPart("FluidPart"); - -# -# importing the solvers needed -SolverType = fluid_only_var.SolverType -if(SolverType == "fractional_step"): - import incompressible_fluid_solver - incompressible_fluid_solver.AddVariables(fluid_model_part) -elif(SolverType == "pressure_splitting"): - import decoupled_solver_eulerian - decoupled_solver_eulerian.AddVariables(fluid_model_part) -elif(SolverType == "monolithic_solver_eulerian"): - import monolithic_solver_eulerian - monolithic_solver_eulerian.AddVariables(fluid_model_part) - fluid_model_part.AddNodalSolutionStepVariable(YIELD_STRESS) -elif(SolverType == "monolithic_solver_eulerian_compressible"): - import monolithic_solver_eulerian_compressible - monolithic_solver_eulerian_compressible.AddVariables(fluid_model_part) -else: - raise "solver type not supported: options are fractional_step - \ - pressure_splitting - monolithic_solver_eulerian - \ - monolithic_solver_eulerian_compressible" - -# introducing input file name -input_file_name = fluid_only_var.problem_name - -# reading the fluid part -gid_mode = GiDPostMode.GiD_PostBinary -multifile = MultiFileFlag.MultipleFiles -deformed_mesh_flag = WriteDeformedMeshFlag.WriteUndeformed -write_conditions = WriteConditionsFlag.WriteElementsOnly -gid_io = GidIO(input_file_name, gid_mode, multifile, deformed_mesh_flag, write_conditions) -model_part_io_fluid = ModelPartIO(input_file_name) -model_part_io_fluid.ReadModelPart(fluid_model_part) - -# setting up the buffer size: SHOULD BE DONE AFTER READING!!! -fluid_model_part.SetBufferSize(3) - -# adding dofs -if(SolverType == "fractional_step"): - incompressible_fluid_solver.AddDofs(fluid_model_part) -elif(SolverType == "pressure_splitting"): - decoupled_solver_eulerian.AddDofs(fluid_model_part) -elif(SolverType == "monolithic_solver_eulerian"): - monolithic_solver_eulerian.AddDofs(fluid_model_part) -elif(SolverType == "monolithic_solver_eulerian_compressible"): - monolithic_solver_eulerian_compressible.AddDofs(fluid_model_part) - -# select here the laplacian form!!!!!!!!!!!!!!!!! -laplacian_form = fluid_only_var.laplacian_form -if(laplacian_form >= 2): - for node in fluid_model_part.Nodes: - node.Free(PRESSURE) - -# check to ensure that no node has zero density or pressure -for node in fluid_model_part.Nodes: - if(node.GetSolutionStepValue(DENSITY) == 0.0): - print("node ", node.Id, " has zero density!") - raise 'node with zero density found' - if(node.GetSolutionStepValue(VISCOSITY) == 0.0): - print("node ", node.Id, " has zero viscosity!") - raise 'node with zero VISCOSITY found' - -# creating the solvers -# fluid solver -if(SolverType == "fractional_step"): - fluid_solver = incompressible_fluid_solver.IncompressibleFluidSolver(fluid_model_part, domain_size) - fluid_solver.laplacian_form = laplacian_form; # standard laplacian form - fluid_solver.predictor_corrector = fluid_only_var.predictor_corrector - fluid_solver.max_press_its = fluid_only_var.max_press_its - fluid_solver.Initialize() -elif(SolverType == "pressure_splitting"): - fluid_solver = decoupled_solver_eulerian.\ - DecoupledSolver(fluid_model_part, domain_size) - oss_switch = fluid_only_var.use_oss - dynamic_tau = fluid_only_var.dynamic_tau -# pPrecond = ILU0Preconditioner() - pPrecond = DiagonalPreconditioner() - fluid_solver.pressure_linear_solver = BICGSTABSolver(1e-3, 5000, pPrecond) -# fluid_solver.linear_solver = SuperLUSolver() - fluid_solver.rel_vel_tol = 1e-4 - fluid_solver.abs_vel_tol = 1e-6 - fluid_solver.rel_pres_tol = 1e-4 - fluid_solver.abs_pres_tol = 1e-6 - fluid_solver.use_inexact_newton = False - fluid_model_part.ProcessInfo.SetValue(OSS_SWITCH, oss_switch) - fluid_model_part.ProcessInfo.SetValue(DYNAMIC_TAU, dynamic_tau) - fluid_solver.Initialize() -elif(SolverType == "monolithic_solver_eulerian"): - fluid_solver = monolithic_solver_eulerian.MonolithicSolver(fluid_model_part, domain_size) - oss_switch = fluid_only_var.use_oss - dynamic_tau = fluid_only_var.dynamic_tau - fluid_model_part.ProcessInfo.SetValue(OSS_SWITCH, oss_switch); - fluid_model_part.ProcessInfo.SetValue(DYNAMIC_TAU, dynamic_tau); - fluid_solver.Initialize() -elif(SolverType == "monolithic_solver_eulerian_compressible"): - fluid_solver = monolithic_solver_eulerian_compressible.MonolithicSolver(fluid_model_part, domain_size) - oss_switch = fluid_only_var.use_oss - dynamic_tau = fluid_only_var.dynamic_tau - fluid_model_part.ProcessInfo.SetValue(OSS_SWITCH, oss_switch); - fluid_model_part.ProcessInfo.SetValue(DYNAMIC_TAU, dynamic_tau); - fluid_solver.Initialize() - - -print("fluid solver created") - -# settings to be changed -Dt = fluid_only_var.Dt -full_Dt = Dt -initial_Dt = 0.001 * full_Dt # 0.05 #0.01 -final_time = fluid_only_var.max_time -output_step = fluid_only_var.output_step - -out = 0 - - -# mesh to be printed -mesh_name = 0.0 -gid_io.InitializeMesh(mesh_name) -gid_io.WriteMesh(fluid_model_part.GetMesh()) -gid_io.FinalizeMesh() - -gid_io.InitializeResults(mesh_name, (fluid_model_part).GetMesh()) - -# -back_node1 = NodeFinder(fluid_model_part.Nodes, 3.0, 0.9, 0.0) -print(back_node1) -back_node2 = NodeFinder(fluid_model_part.Nodes, 3.0, 0.95, 0.0) -print(back_node2) - -time = 0.0 -step = 0 -while(time < final_time): - - if(step < 5): - Dt = initial_Dt - else: - Dt = full_Dt - - time = time + Dt - fluid_model_part.CloneTimeStep(time) - - if(step >= 3): - fluid_solver.Solve() - BenchmarkCheck(time, back_node1, back_node2) - - if(out == output_step): - if(SolverType == "fractional_step" or SolverType == "pressure_splitting"): - gid_io.WriteNodalResults(PRESSURE, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(VELOCITY, fluid_model_part.Nodes, time, 0) - else: - gid_io.WriteNodalResults(PRESSURE, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(AIR_PRESSURE, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(WATER_PRESSURE, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(VELOCITY, fluid_model_part.Nodes, time, 0) - # gid_io.WriteNodalResults(DISPLACEMENT,fluid_model_part.Nodes,time,0) - gid_io.WriteNodalResults(MESH_VELOCITY, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(IS_STRUCTURE, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(IS_BOUNDARY, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(IS_POROUS, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(IS_FREE_SURFACE, fluid_model_part.Nodes, time, 0) - # gid_io.PrintOnGaussPoints(THAWONE,fluid_model_part,time) - # gid_io.PrintOnGaussPoints(THAWTWO,fluid_model_part,time) - gid_io.WriteNodalResults(ADVPROJ, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(DIVPROJ, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(DENSITY, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(DENSITY_AIR, fluid_model_part.Nodes, time, 0) - # gid_io.WriteNodalResults(NODAL_H,fluid_model_part.Nodes,time,0) - gid_io.WriteNodalResults(VISCOSITY, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(SOUND_VELOCITY, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(AIR_SOUND_VELOCITY, fluid_model_part.Nodes, time, 0) - gid_io.WriteNodalResults(EXTERNAL_PRESSURE, fluid_model_part.Nodes, time, 0) - gid_io.PrintOnGaussPoints(TEMPERATURE, fluid_model_part, time) - gid_io.PrintOnGaussPoints(AUX_INDEX, fluid_model_part, time) - - out = 0 - - out = out + 1 - step = step + 1 - -gid_io.FinalizeResults() diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette2dNonNewt_ref.txt b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette2dNonNewt_ref.txt deleted file mode 100644 index 11bf2d64cf79..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette2dNonNewt_ref.txt +++ /dev/null @@ -1,1056 +0,0 @@ -KRATOS_BENCHMARK | Float | Time | 4e-05 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.00226117865784 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.00384099862504 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 5e-05 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.00514963981093 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.00683648195905 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.01005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.173468358429 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.120735970833 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.02005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0105073546828 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0102808288055 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.03005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0102676854245 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101488158023 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.04005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103698271309 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010204899056 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.05005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103447303222 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101911332364 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.06005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103495375842 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101936816162 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.07005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103492208701 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101935461562 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.08005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103492327477 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193558523 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.09005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103492215023 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101935561079 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.10005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103492471589 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101935715521 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.11005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103492776666 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101935896393 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.12005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103493120788 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101936098383 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.13005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103493463422 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101936299979 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.14005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103493794944 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101936495311 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.15005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103494109319 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101936680775 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.16005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103494404979 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101936855311 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.17005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103494681764 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101937018756 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.18005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349494032 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101937171449 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.19005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103495181599 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101937313928 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.20005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103495406669 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101937446815 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.21005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103495616611 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101937570744 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.22005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103495812476 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101937686332 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.23005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103495995259 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101937794169 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.24005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103496165897 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101937894809 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.25005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349632526 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101937988768 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.26005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103496474157 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938076525 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.27005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103496613338 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938158524 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.28005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103496743496 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938235178 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.29005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103496865271 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938306865 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.30005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103496979254 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938373938 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.31005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497085991 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193843672 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.32005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497185987 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938495511 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.33005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497279707 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938550588 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.34005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497367583 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938602207 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.35005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497450011 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938650604 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.36005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497527361 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938695997 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.37005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497599972 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193873859 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.38005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349766816 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938778569 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.39005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497732217 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938816109 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.40005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497792413 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938851369 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.41005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497849001 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938884499 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.42005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497902213 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938915638 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.43005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497952265 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938944914 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.44005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103497999359 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938972447 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.45005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498043681 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101938998347 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.46005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498085407 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939022718 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.47005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498124698 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939045655 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.48005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498161705 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193906725 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.49005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498196568 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939087584 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.50005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349822942 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939106736 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.51005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498260383 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939124778 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.52005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498289571 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939141778 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.53005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498317092 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.01019391578 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.54005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498343044 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939172903 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.55005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498367523 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939187141 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.56005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498390616 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939200567 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.57005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498412404 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939213229 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.58005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498432964 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939225173 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.59005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498452369 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939236441 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.60005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498470685 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939247072 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.61005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498487977 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939257104 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.62005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498504303 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939266573 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.63005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349851972 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193927551 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.64005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498534279 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939283947 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.65005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349854803 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939291912 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.66005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498561019 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939299434 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.67005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349857329 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939306536 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.68005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498584883 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939313244 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.69005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498595837 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193931958 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.70005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498606188 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939325565 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.71005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349861597 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939331219 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.72005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498625215 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193933656 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.73005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498633953 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939341608 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.74005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498642213 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939346377 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.75005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498650022 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939350884 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.76005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498657403 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939355143 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.77005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498664382 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939359169 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.78005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498670981 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939362974 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.79005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498677221 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939366571 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.80005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498683121 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939369972 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.81005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498688701 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939373186 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.82005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498693978 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939376226 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.83005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498698969 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939379099 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.84005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349870369 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939381817 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.85005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498708155 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939384386 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.86005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498712378 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939386816 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.87005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498716373 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939389114 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.88005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498720153 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939391287 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.89005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498723729 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939393343 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.90005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498727112 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939395287 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.91005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498730312 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939397126 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.92005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349873334 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939398865 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.93005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498736206 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939400511 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.94005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498738917 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939402068 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.95005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498741483 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193940354 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.96005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349874391 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939404934 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.97005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498746208 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939406252 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.98005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498748382 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939407499 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.99005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349875044 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939408679 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.00005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498752387 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939409796 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.01005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349875423 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939410853 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.02005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498755975 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939411852 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.03005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498757626 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939412799 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.04005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498759189 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939413694 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.05005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498760668 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939414542 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.06005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498762069 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939415343 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.07005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498763394 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939416103 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.08005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498764649 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939416821 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.09005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498765837 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939417501 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.10005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498766961 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939418144 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.11005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498768026 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939418754 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.12005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498769034 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193941933 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.13005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498769988 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939419876 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.14005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498770891 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939420393 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.15005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498771747 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939420882 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.16005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498772557 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939421345 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.17005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498773323 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939421783 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.18005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498774049 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939422198 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.19005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498774737 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939422591 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.20005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498775388 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939422963 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.21005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498776004 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939423315 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.22005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498776588 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939423648 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.23005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349877714 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939423964 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.24005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498777664 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939424263 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.25005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498778159 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939424546 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.26005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498778629 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939424814 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.27005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498779073 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939425068 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.28005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498779494 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939425308 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.29005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498779893 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939425535 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.30005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878027 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939425751 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.31005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498780628 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939425955 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.32005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498780966 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939426148 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.33005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498781287 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939426331 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.34005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498781591 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939426504 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.35005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498781879 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939426668 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.36005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498782151 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939426824 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.37005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498782409 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939426971 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.38005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498782654 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942711 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.39005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498782885 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939427242 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.40005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498783105 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939427368 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.41005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498783312 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939427486 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.42005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498783509 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939427598 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.43005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498783696 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939427704 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.44005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498783872 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939427805 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.45005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878404 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.01019394279 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.46005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498784198 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939427991 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.47005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498784348 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428076 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.48005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498784491 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428157 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.49005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498784625 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428234 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.50005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498784753 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428307 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.51005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498784874 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428376 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.52005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498784989 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428441 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.53005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498785097 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428503 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.54005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.01034987852 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428561 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.55005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498785297 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428617 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.56005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878539 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428669 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.57005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498785477 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428719 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.58005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878556 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428766 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.59005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498785639 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428811 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.60005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498785713 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428853 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.61005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498785784 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428893 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.62005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878585 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428932 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.63005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498785914 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939428968 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.64005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498785974 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429002 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.65005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786031 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429034 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.66005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786084 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429065 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.67005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786135 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429094 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.68005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786184 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429121 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.69005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878623 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429147 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.70005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786273 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429172 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.71005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786314 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429195 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.72005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786353 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429218 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.73005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878639 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429239 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.74005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786425 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429259 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.75005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786459 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429277 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.76005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878649 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429295 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.77005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878652 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429312 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.78005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786548 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429328 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.79005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786575 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429344 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.80005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.01034987866 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429358 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.81005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786624 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429372 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.82005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786647 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429385 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.83005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786669 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429397 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.84005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786689 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429409 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.85005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786709 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942942 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.86005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786727 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942943 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.87005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786745 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942944 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.88005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786761 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429449 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.89005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786777 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429458 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.90005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786792 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429467 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.91005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786806 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429475 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.92005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786819 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429482 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.93005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786832 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942949 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.94005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786844 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429496 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.95005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786855 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429503 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.96005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786866 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429509 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.97005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786876 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429515 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.98005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786886 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942952 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 1.99005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786895 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429526 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.00005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786904 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942953 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.01005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786912 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429535 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.02005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878692 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942954 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.03005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786927 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429544 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.04005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786934 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429548 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.05005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786941 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429552 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.06005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786947 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429555 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.07005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786953 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429559 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.08005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786959 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429562 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.09005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786964 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429565 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.10005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878697 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429568 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.11005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786974 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429571 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.12005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786979 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429573 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.13005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786983 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429576 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.14005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786987 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429578 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.15005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786991 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942958 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.16005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786995 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429582 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.17005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498786999 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429584 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.18005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787002 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429586 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.19005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787005 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429588 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.20005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787008 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942959 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.21005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787011 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429591 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.22005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787014 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429593 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.23005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787016 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429594 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.24005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787019 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429596 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.25005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787021 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429597 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.26005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787023 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429598 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.27005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787025 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.01019394296 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.28005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787027 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429601 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.29005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787029 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429602 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.30005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787031 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429603 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.31005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787033 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429604 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.32005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787034 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429605 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.33005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787036 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429605 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.34005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787037 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429606 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.35005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787038 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429607 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.36005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878704 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429608 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.37005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787041 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429608 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.38005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787042 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429609 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.39005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787043 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942961 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.40005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787044 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942961 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.41005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787045 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429611 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.42005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787046 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429611 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.43005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787047 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429612 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.44005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787048 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429612 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.45005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787049 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429613 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.46005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878705 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429613 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.47005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878705 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429614 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.48005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787051 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429614 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.49005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787052 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429614 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.50005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787052 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429615 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.51005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787053 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429615 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.52005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787053 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429615 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.53005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787054 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429616 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.54005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787054 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429616 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.55005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787055 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429616 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.56005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787055 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429617 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.57005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787056 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429617 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.58005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787056 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429617 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.59005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787056 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429617 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.60005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787057 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429617 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.61005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787057 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429618 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.62005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787058 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429618 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.63005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787058 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429618 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.64005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787058 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429618 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.65005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787058 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429618 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.66005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787059 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429618 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.67005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787059 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429619 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.68005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787059 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429619 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.69005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787059 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429619 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.70005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878706 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429619 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.71005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878706 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429619 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.72005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878706 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429619 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.73005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878706 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429619 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.74005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.010349878706 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429619 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.75005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787061 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429619 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.76005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787061 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.77005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787061 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.78005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787061 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.79005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787061 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.80005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787061 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.81005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787061 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.82005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787061 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.83005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.84005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.85005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.86005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.87005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.88005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.89005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.90005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.91005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.010193942962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.92005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.93005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.94005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787062 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.95005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.96005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.97005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.98005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 2.99005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.00005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.01005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.02005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.03005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.04005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.05005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.06005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.07005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.08005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.09005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.10005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.11005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.12005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.13005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.14005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.15005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.16005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.17005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.18005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.19005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.20005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.21005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.22005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.23005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.24005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.25005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.26005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.27005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.28005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.29005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.30005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.31005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.32005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.33005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.34005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.35005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.36005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.37005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.38005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.39005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787063 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.40005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.41005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.42005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.43005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.44005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.45005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.46005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.47005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.48005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.49005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 3.50005 | None | None -KRATOS_BENCHMARK | Float | Node 1 velocity_x | 0.0103498787064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_x | 0.0101939429621 | 0.01 | 1e-05 diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.cnd b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.cnd deleted file mode 100755 index 6597166fb12a..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.cnd +++ /dev/null @@ -1,1786 +0,0 @@ -BOOK:Nodal Values -NUMBER: 1 CONDITION: point_DISPLACEMENT -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 2 CONDITION: line_DISPLACEMENT -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 3 CONDITION: surface_DISPLACEMENT -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 4 CONDITION: volume_DISPLACEMENT -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 5 CONDITION: point_VELOCITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 6 CONDITION: line_VELOCITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 7 CONDITION: surface_VELOCITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 8 CONDITION: volume_VELOCITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 9 CONDITION: point_MESH_VELOCITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 10 CONDITION: line_MESH_VELOCITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 11 CONDITION: surface_MESH_VELOCITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 12 CONDITION: volume_MESH_VELOCITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 13 CONDITION: point_BODY_FORCE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BODY_FORCE_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 14 CONDITION: line_BODY_FORCE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BODY_FORCE_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 15 CONDITION: surface_BODY_FORCE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BODY_FORCE_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 16 CONDITION: volume_BODY_FORCE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BODY_FORCE_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 17 CONDITION: point_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 18 CONDITION: line_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 19 CONDITION: surface_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 20 CONDITION: volume_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 21 CONDITION: point_AIR_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: AIR_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 22 CONDITION: line_AIR_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: AIR_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 23 CONDITION: surface_AIR_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: AIR_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 24 CONDITION: volume_AIR_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: AIR_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 25 CONDITION: point_WATER_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: WATER_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 26 CONDITION: line_WATER_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: WATER_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 27 CONDITION: surface_WATER_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: WATER_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 28 CONDITION: volume_WATER_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: WATER_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 29 CONDITION: point_EXTERNAL_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 30 CONDITION: line_EXTERNAL_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 31 CONDITION: surface_EXTERNAL_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 32 CONDITION: volume_EXTERNAL_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 33 CONDITION: point_VISCOSITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: VISCOSITY -VALUE: 0.000001 -END CONDITION -NUMBER: 34 CONDITION: line_VISCOSITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: VISCOSITY -VALUE: 0.000001 -END CONDITION -NUMBER: 35 CONDITION: surface_VISCOSITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: VISCOSITY -VALUE: 0.000001 -END CONDITION -NUMBER: 36 CONDITION: volume_VISCOSITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: VISCOSITY -VALUE: 0.000001 -END CONDITION -NUMBER: 37 CONDITION: point_DENSITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DENSITY -VALUE: 1.0 -END CONDITION -NUMBER: 38 CONDITION: line_DENSITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DENSITY -VALUE: 1.0 -END CONDITION -NUMBER: 39 CONDITION: surface_DENSITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DENSITY -VALUE: 1.0 -END CONDITION -NUMBER: 40 CONDITION: volume_DENSITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DENSITY -VALUE: 1.0 -END CONDITION -NUMBER: 41 CONDITION: point_DENSITY_AIR -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DENSITY_AIR -VALUE: 1.0 -END CONDITION -NUMBER: 42 CONDITION: line_DENSITY_AIR -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DENSITY_AIR -VALUE: 1.0 -END CONDITION -NUMBER: 43 CONDITION: surface_DENSITY_AIR -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DENSITY_AIR -VALUE: 1.0 -END CONDITION -NUMBER: 44 CONDITION: volume_DENSITY_AIR -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DENSITY_AIR -VALUE: 1.0 -END CONDITION -NUMBER: 45 CONDITION: point_POROSITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: POROSITY -VALUE: 1.0 -END CONDITION -NUMBER: 46 CONDITION: line_POROSITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: POROSITY -VALUE: 1.0 -END CONDITION -NUMBER: 47 CONDITION: surface_POROSITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: POROSITY -VALUE: 1.0 -END CONDITION -NUMBER: 48 CONDITION: volume_POROSITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: POROSITY -VALUE: 1.0 -END CONDITION -NUMBER: 49 CONDITION: point_YIELD_STRESS -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: YIELD_STRESS -VALUE: 100.0 -END CONDITION -NUMBER: 50 CONDITION: line_YIELD_STRESS -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: YIELD_STRESS -VALUE: 100.0 -END CONDITION -NUMBER: 51 CONDITION: surface_YIELD_STRESS -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: YIELD_STRESS -VALUE: 100.0 -END CONDITION -NUMBER: 52 CONDITION: volume_YIELD_STRESS -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: YIELD_STRESS -VALUE: 100.0 -END CONDITION -NUMBER: 53 CONDITION: point_IS_INTERFACE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 54 CONDITION: line_IS_INTERFACE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 55 CONDITION: surface_IS_INTERFACE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 56 CONDITION: volume_IS_INTERFACE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 57 CONDITION: point_FLAG_VARIABLE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 58 CONDITION: line_FLAG_VARIABLE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 59 CONDITION: surface_FLAG_VARIABLE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 60 CONDITION: volume_FLAG_VARIABLE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 61 CONDITION: point_IS_BOUNDARY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 62 CONDITION: line_IS_BOUNDARY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 63 CONDITION: surface_IS_BOUNDARY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 64 CONDITION: volume_IS_BOUNDARY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 65 CONDITION: point_IS_SLIP -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_SLIP#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 66 CONDITION: line_IS_SLIP -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_SLIP#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 67 CONDITION: surface_IS_SLIP -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_SLIP#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 68 CONDITION: volume_IS_SLIP -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_SLIP#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -BOOK:Elements -NUMBER: 69 CONDITION: surface_Fluid2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 70 CONDITION: volume_Fluid3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 71 CONDITION: surface_Fluid2DCoupled -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 72 CONDITION: volume_Fluid3DCoupled -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 73 CONDITION: surface_ASGS2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 74 CONDITION: volume_ASGS3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 75 CONDITION: surface_ASGSCompressible2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 76 CONDITION: surface_NoNewtonianASGS2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 77 CONDITION: surface_CouetteNonNewtonianASGS2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -BOOK:Conditions -NUMBER: 78 CONDITION: line_Condition2D -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 79 CONDITION: surface_Condition3D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 80 CONDITION: line_Fluid2DNeumann -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 81 CONDITION: surface_Fluid3DNeumann -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 82 CONDITION: line_Monolithic2DNeumann -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 83 CONDITION: surface_Monolithic3DNeumann -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -BOOK:Conditional Data -NUMBER: 84 CONDITION: line_IS_STRUCTURE -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(0.0,1.0) -VALUE: 0.0 -END CONDITION -NUMBER: 85 CONDITION: surface_IS_STRUCTURE -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(0.0,1.0) -VALUE: 0.0 -END CONDITION -BOOK:Model Parts -NUMBER: 86 CONDITION: point_VelocityInlet -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -END CONDITION -NUMBER: 87 CONDITION: line_VelocityInlet -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -END CONDITION -NUMBER: 88 CONDITION: surface_VelocityInlet -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -END CONDITION -NUMBER: 89 CONDITION: point_SlipCondition -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DIS_STRUCTURE -VALUE: BEGIN2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_STRUCTURE -VALUE: END2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: BEGIN3DIS_STRUCTURE -VALUE: BEGIN3DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END3DIS_STRUCTURE -VALUE: END3DIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 90 CONDITION: line_SlipCondition -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DIS_STRUCTURE -VALUE: BEGIN2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_STRUCTURE -VALUE: END2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: BEGIN3DIS_STRUCTURE -VALUE: BEGIN3DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END3DIS_STRUCTURE -VALUE: END3DIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 91 CONDITION: surface_SlipCondition -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DIS_STRUCTURE -VALUE: BEGIN2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_STRUCTURE -VALUE: END2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: BEGIN3DIS_STRUCTURE -VALUE: BEGIN3DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END3DIS_STRUCTURE -VALUE: END3DIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 92 CONDITION: point_NoSlipCondition -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -END CONDITION -NUMBER: 93 CONDITION: line_NoSlipCondition -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -END CONDITION -NUMBER: 94 CONDITION: surface_NoSlipCondition -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -END CONDITION -NUMBER: 95 CONDITION: point_FixedPressureCondition -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINPRESSURE -VALUE: BEGINPRESSURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: PRESSURE -VALUE: 0.0 -QUESTION: ENDPRESSURE -VALUE: ENDPRESSURE -STATE: HIDDEN -END CONDITION -NUMBER: 96 CONDITION: line_FixedPressureCondition -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINPRESSURE -VALUE: BEGINPRESSURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: PRESSURE -VALUE: 0.0 -QUESTION: ENDPRESSURE -VALUE: ENDPRESSURE -STATE: HIDDEN -END CONDITION -NUMBER: 97 CONDITION: surface_FixedPressureCondition -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINPRESSURE -VALUE: BEGINPRESSURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: PRESSURE -VALUE: 0.0 -QUESTION: ENDPRESSURE -VALUE: ENDPRESSURE -STATE: HIDDEN -END CONDITION -BOOK:Default -NUMBER: 98 CONDITION: line_2D_Boundary_Condition -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: 2D_Boundary_Condition#CB#(Condition2D,Fluid2DNeumann,Monolithic2DNeumann) -VALUE: Condition2D -END CONDITION -NUMBER: 99 CONDITION: surface_3D_Boundary_Condition -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: 3D_Boundary_Condition#CB#(Condition3D,Fluid3DNeumann,Monolithic3DNeumann) -VALUE: Condition3D -END CONDITION -NUMBER: 100 CONDITION: surface_2D_Body_Element -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: 2D_Body_Element#CB#(Fluid2D,Fluid2DCoupled,ASGS2D,ASGSCompressible2D,NoNewtonianASGS2D,CouetteNonNewtonianASGS2D) -VALUE: Fluid2D -END CONDITION -NUMBER: 101 CONDITION: volume_3D_Body_Element -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: 3D_Body_Element#CB#(Fluid3D,Fluid3DCoupled,ASGS3D) -VALUE: Fluid3D -END CONDITION -NUMBER: 102 CONDITION: point_Boundary -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Boundary_Condition -VALUE: BEGIN2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: 2D_Boundary_Condition#CB#(Condition2D,Fluid2DNeumann,Monolithic2DNeumann) -VALUE: Use_Default -QUESTION: END2D2D_Boundary_Condition -VALUE: END2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: BEGIN3D3D_Boundary_Condition -VALUE: BEGIN3D3D_Boundary_Condition -STATE: HIDDEN -QUESTION: 3D_Boundary_Condition#CB#(Condition3D,Fluid3DNeumann,Monolithic3DNeumann) -VALUE: Use_Default -QUESTION: END3D3D_Boundary_Condition -VALUE: END3D3D_Boundary_Condition -STATE: HIDDEN -QUESTION: BEGIN2DDISPLACEMENT -VALUE: BEGIN2DDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: END2DDISPLACEMENT -VALUE: END2DDISPLACEMENT -STATE: HIDDEN -QUESTION: BEGIN3DDISPLACEMENT -VALUE: BEGIN3DDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: END3DDISPLACEMENT -VALUE: END3DDISPLACEMENT -STATE: HIDDEN -END CONDITION -NUMBER: 103 CONDITION: line_Boundary -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Boundary_Condition -VALUE: BEGIN2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: 2D_Boundary_Condition#CB#(Condition2D,Fluid2DNeumann,Monolithic2DNeumann) -VALUE: Use_Default -QUESTION: END2D2D_Boundary_Condition -VALUE: END2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: BEGIN3D3D_Boundary_Condition -VALUE: BEGIN3D3D_Boundary_Condition -STATE: HIDDEN -QUESTION: 3D_Boundary_Condition#CB#(Condition3D,Fluid3DNeumann,Monolithic3DNeumann) -VALUE: Use_Default -QUESTION: END3D3D_Boundary_Condition -VALUE: END3D3D_Boundary_Condition -STATE: HIDDEN -QUESTION: BEGIN2DDISPLACEMENT -VALUE: BEGIN2DDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: END2DDISPLACEMENT -VALUE: END2DDISPLACEMENT -STATE: HIDDEN -QUESTION: BEGIN3DDISPLACEMENT -VALUE: BEGIN3DDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: END3DDISPLACEMENT -VALUE: END3DDISPLACEMENT -STATE: HIDDEN -END CONDITION -NUMBER: 104 CONDITION: surface_Boundary -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Boundary_Condition -VALUE: BEGIN2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: 2D_Boundary_Condition#CB#(Condition2D,Fluid2DNeumann,Monolithic2DNeumann) -VALUE: Use_Default -QUESTION: END2D2D_Boundary_Condition -VALUE: END2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: BEGIN3D3D_Boundary_Condition -VALUE: BEGIN3D3D_Boundary_Condition -STATE: HIDDEN -QUESTION: 3D_Boundary_Condition#CB#(Condition3D,Fluid3DNeumann,Monolithic3DNeumann) -VALUE: Use_Default -QUESTION: END3D3D_Boundary_Condition -VALUE: END3D3D_Boundary_Condition -STATE: HIDDEN -QUESTION: BEGIN2DDISPLACEMENT -VALUE: BEGIN2DDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: END2DDISPLACEMENT -VALUE: END2DDISPLACEMENT -STATE: HIDDEN -QUESTION: BEGIN3DDISPLACEMENT -VALUE: BEGIN3DDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: END3DDISPLACEMENT -VALUE: END3DDISPLACEMENT -STATE: HIDDEN -END CONDITION -NUMBER: 105 CONDITION: surface_Body -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Body_Element -VALUE: BEGIN2D2D_Body_Element -STATE: HIDDEN -QUESTION: 2D_Body_Element#CB#(Fluid2D,Fluid2DCoupled,ASGS2D,ASGSCompressible2D,NoNewtonianASGS2D,CouetteNonNewtonianASGS2D) -VALUE: Use_Default -QUESTION: END2D2D_Body_Element -VALUE: END2D2D_Body_Element -STATE: HIDDEN -QUESTION: BEGIN3D3D_Body_Element -VALUE: BEGIN3D3D_Body_Element -STATE: HIDDEN -QUESTION: 3D_Body_Element#CB#(Fluid3D,Fluid3DCoupled,ASGS3D) -VALUE: Use_Default -QUESTION: END3D3D_Body_Element -VALUE: END3D3D_Body_Element -STATE: HIDDEN -END CONDITION -NUMBER: 106 CONDITION: volume_Body -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Body_Element -VALUE: BEGIN2D2D_Body_Element -STATE: HIDDEN -QUESTION: 2D_Body_Element#CB#(Fluid2D,Fluid2DCoupled,ASGS2D,ASGSCompressible2D,NoNewtonianASGS2D,CouetteNonNewtonianASGS2D) -VALUE: Use_Default -QUESTION: END2D2D_Body_Element -VALUE: END2D2D_Body_Element -STATE: HIDDEN -QUESTION: BEGIN3D3D_Body_Element -VALUE: BEGIN3D3D_Body_Element -STATE: HIDDEN -QUESTION: 3D_Body_Element#CB#(Fluid3D,Fluid3DCoupled,ASGS3D) -VALUE: Use_Default -QUESTION: END3D3D_Body_Element -VALUE: END3D3D_Body_Element -STATE: HIDDEN -END CONDITION diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.cond b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.cond deleted file mode 100755 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.elem b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.elem deleted file mode 100755 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.geo b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.geo deleted file mode 100755 index 8f7fd04adac0..000000000000 Binary files a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.geo and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.info b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.info deleted file mode 100755 index ac4a5195a88d..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.info +++ /dev/null @@ -1,1868 +0,0 @@ -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: False -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosMKLSolversApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: True -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -importing KratosIncompressibleFluidApplication ... -KratosIncompressibleFluidApplication lib loaded -KratosIncompressibleFluidApplication application created -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing KratosIncompressibleFluidApplication... -Initializing KratosIncompressibleFluidApplication...Register completed -Initializing KratosIncompressibleFluidApplication...variables succesfully registered -Initializing KratosIncompressibleFluidApplication...elements succesfully registered -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosIncompressibleFluidApplication Succesfully imported -variables for the MONOLITHIC_SOLVER_EULERIAN added correctly -CouetteNonNewtonian2d opened for io -CouetteNonNewtonian2d.node opened for io -CouetteNonNewtonian2d.prop opened for io -CouetteNonNewtonian2d.elem opened for io -CouetteNonNewtonian2d.cond opened for io -CouetteNonNewtonian2d.init opened for io -initializing result files - Reading Nodes : 2836 nodes read - Reading Elements : 5390 CouetteNonNewtonianASGS2D read -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DISPLACEMENT_X -rVariable : DISPLACEMENT_X component of DISPLACEMENT variable #94 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DISPLACEMENT_Y -rVariable : DISPLACEMENT_Y component of DISPLACEMENT variable #95 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DISPLACEMENT_Z -rVariable : DISPLACEMENT_Z component of DISPLACEMENT variable #96 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VELOCITY_X -rVariable : VELOCITY_X component of VELOCITY variable #288 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VELOCITY_Y -rVariable : VELOCITY_Y component of VELOCITY variable #289 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VELOCITY_Z -rVariable : VELOCITY_Z component of VELOCITY variable #290 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : EXTERNAL_PRESSURE -rVariable : EXTERNAL_PRESSURE variable #116 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VISCOSITY -rVariable : VISCOSITY variable #291 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DENSITY -rVariable : DENSITY variable #82 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : YIELD_STRESS -rVariable : YIELD_STRESS variable #310 -lines read : 18717 -dofs for the monolithic solver added correctly -using the velocity Bossak Time Integration Scheme -fluid solver created -writing a 2D mesh -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs -matrix_partition : [5](0,2006,4012,6018,8024) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.020539 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.52 -Factor flops = 1.298301e+08 Mflops = 251.28 -Solve time = 0.00 -VELOCITY CRITERIA :: obtained ratio = 0.652313; expected ratio = 1e-05obtained abs = 1.66906e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1; expected ratio = 1e-05obtained abs = 18.431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.02033 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.72 -Factor flops = 1.303041e+08 Mflops = 181.82 -Solve time = 0.00 -VELOCITY CRITERIA :: obtained ratio = 0.0393049; expected ratio = 1e-05obtained abs = 1.02016e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00677594; expected ratio = 1e-05obtained abs = 0.124742; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0206261 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.83 -Factor flops = 1.301892e+08 Mflops = 156.23 -Solve time = 0.03 -Solve flops = 2.779584e+06 Mflops = 83.39 -VELOCITY CRITERIA :: obtained ratio = 0.0146675; expected ratio = 1e-05obtained abs = 3.82802e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00226467; expected ratio = 1e-05obtained abs = 0.0416858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.02037 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.82 -Factor flops = 1.301396e+08 Mflops = 159.35 -Solve time = 0.03 -Solve flops = 2.779896e+06 Mflops = 83.40 -VELOCITY CRITERIA :: obtained ratio = 0.0101367; expected ratio = 1e-05obtained abs = 2.64884e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00147896; expected ratio = 1e-05obtained abs = 0.0272272; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.020304 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.20 -Factor flops = 1.307492e+08 Mflops = 653.75 -Solve time = 0.00 -VELOCITY CRITERIA :: obtained ratio = 0.00885253; expected ratio = 1e-05obtained abs = 2.31383e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00138847; expected ratio = 1e-05obtained abs = 0.0255661; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.020632 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.33 -Factor flops = 1.306884e+08 Mflops = 392.07 -Solve time = 0.02 -Solve flops = 2.787918e+06 Mflops = 167.28 -VELOCITY CRITERIA :: obtained ratio = 0.00719239; expected ratio = 1e-05obtained abs = 1.88056e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00126032; expected ratio = 1e-05obtained abs = 0.0231994; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.020366 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.52 -Factor flops = 1.306520e+08 Mflops = 252.87 -Solve time = 0.02 -Solve flops = 2.786876e+06 Mflops = 167.21 -VELOCITY CRITERIA :: obtained ratio = 0.00540474; expected ratio = 1e-05obtained abs = 1.41416e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000847285; expected ratio = 1e-05obtained abs = 0.0155977; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0203722 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.68 -Factor flops = 1.306677e+08 Mflops = 191.22 -Solve time = 0.00 -VELOCITY CRITERIA :: obtained ratio = 0.00414214; expected ratio = 1e-05obtained abs = 1.08434e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000695996; expected ratio = 1e-05obtained abs = 0.0128146; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0261919 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.80 -Factor flops = 1.307290e+08 Mflops = 163.41 -Solve time = 0.02 -Solve flops = 2.788678e+06 Mflops = 167.32 -VELOCITY CRITERIA :: obtained ratio = 0.0030593; expected ratio = 1e-05obtained abs = 8.01253e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000580015; expected ratio = 1e-05obtained abs = 0.0106791; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs -matrix_partition : [5](0,2006,4012,6018,8024) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0203161 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.82 -Factor flops = 1.306621e+08 Mflops = 159.99 -Solve time = 0.05 -Solve flops = 2.787824e+06 Mflops = 55.76 -VELOCITY CRITERIA :: obtained ratio = 0.486119; expected ratio = 1e-05obtained abs = 2.0896e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0213261; expected ratio = 1e-05obtained abs = 0.393571; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.020505 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.22 -Factor flops = 1.301783e+08 Mflops = 600.82 -Solve time = 0.00 -VELOCITY CRITERIA :: obtained ratio = 0.0639006; expected ratio = 1e-05obtained abs = 2.91148e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01592; expected ratio = 1e-05obtained abs = 0.293376; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0207891 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.43 -Factor flops = 1.307695e+08 Mflops = 301.78 -Solve time = 0.02 -Solve flops = 2.789972e+06 Mflops = 167.40 -VELOCITY CRITERIA :: obtained ratio = 0.0143169; expected ratio = 1e-05obtained abs = 6.57278e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00239198; expected ratio = 1e-05obtained abs = 0.0440725; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0207241 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.57 -Factor flops = 1.309182e+08 Mflops = 231.03 -Solve time = 0.02 -Solve flops = 2.793424e+06 Mflops = 167.61 -VELOCITY CRITERIA :: obtained ratio = 0.00974212; expected ratio = 1e-05obtained abs = 4.48461e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00213185; expected ratio = 1e-05obtained abs = 0.0392831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0206609 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.72 -Factor flops = 1.313706e+08 Mflops = 183.31 -Solve time = 0.00 -VELOCITY CRITERIA :: obtained ratio = 0.00742889; expected ratio = 1e-05obtained abs = 3.4267e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00129624; expected ratio = 1e-05obtained abs = 0.023886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0206411 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.80 -Factor flops = 1.313776e+08 Mflops = 164.22 -Solve time = 0.07 -Solve flops = 2.799236e+06 Mflops = 41.99 -VELOCITY CRITERIA :: obtained ratio = 0.0053017; expected ratio = 1e-05obtained abs = 2.44983e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000795436; expected ratio = 1e-05obtained abs = 0.0146566; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.020673 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.80 -Factor flops = 1.314215e+08 Mflops = 164.28 -Solve time = 0.05 -Solve flops = 2.800054e+06 Mflops = 56.00 -VELOCITY CRITERIA :: obtained ratio = 0.00380391; expected ratio = 1e-05obtained abs = 1.76004e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000577259; expected ratio = 1e-05obtained abs = 0.0106363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0206611 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.20 -Factor flops = 1.315389e+08 Mflops = 657.69 -Solve time = 0.00 -VELOCITY CRITERIA :: obtained ratio = 0.00278837; expected ratio = 1e-05obtained abs = 1.29138e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00040518; expected ratio = 1e-05obtained abs = 0.00746512; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.0208549 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.35 -Factor flops = 1.317133e+08 Mflops = 376.32 -Solve time = 0.02 -Solve flops = 2.804088e+06 Mflops = 168.25 -VELOCITY CRITERIA :: obtained ratio = 0.00213876; expected ratio = 1e-05obtained abs = 9.91191e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000361488; expected ratio = 1e-05obtained abs = 0.00665966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs -matrix_partition : [5](0,2006,4012,6018,8024) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.020602 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 -Factor time = 0.60 -Factor flops = 1.323703e+08 Mflops = 220.62 -Solve time = 0.00 -VELOCITY CRITERIA :: obtained ratio = 0.606395; expected ratio = 1e-05obtained abs = 6.59305e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0294499; expected ratio = 1e-05obtained abs = 0.543139; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 1e-05obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,1347,2694,4041,5390) -time: 0.020905 -"finished parallel building" : finished parallel building -matrix size in solver: 8024 -RHS size in solver: 8024 -I am here - - -Matrix storage type: 0 diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.init b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.init deleted file mode 100755 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.lin b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.lin deleted file mode 100755 index 4e556d1175fd..000000000000 Binary files a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.lin and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.mdpa b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.mdpa deleted file mode 100755 index e2cbdd22ef16..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.mdpa +++ /dev/null @@ -1,18716 +0,0 @@ -Begin ModelPartData -// VARIABLE_NAME value -End ModelPartData - -Begin Properties 0 -End Properties - - -Begin Nodes -1 0.00000e+00 0.00000e+00 0.00000e+00 -2 0.00000e+00 5.00000e-02 0.00000e+00 -3 5.00000e-02 0.00000e+00 0.00000e+00 -4 7.08333e-02 4.44177e-02 0.00000e+00 -5 0.00000e+00 1.00000e-01 0.00000e+00 -6 1.00000e-01 0.00000e+00 0.00000e+00 -7 5.00000e-02 8.66025e-02 0.00000e+00 -8 1.00000e-01 8.66025e-02 0.00000e+00 -9 1.25000e-01 4.33013e-02 0.00000e+00 -10 0.00000e+00 1.50000e-01 0.00000e+00 -11 7.50000e-02 1.29904e-01 0.00000e+00 -12 1.50000e-01 0.00000e+00 0.00000e+00 -13 1.50000e-01 8.66025e-02 0.00000e+00 -14 1.25000e-01 1.29904e-01 0.00000e+00 -15 1.75000e-01 4.33013e-02 0.00000e+00 -16 4.47028e-02 1.79194e-01 0.00000e+00 -17 0.00000e+00 2.00000e-01 0.00000e+00 -18 2.00000e-01 0.00000e+00 0.00000e+00 -19 9.86420e-02 1.90270e-01 0.00000e+00 -20 1.75000e-01 1.29904e-01 0.00000e+00 -21 2.00000e-01 8.66025e-02 0.00000e+00 -22 2.25000e-01 4.33013e-02 0.00000e+00 -23 4.98719e-02 2.25795e-01 0.00000e+00 -24 1.59397e-01 1.82594e-01 0.00000e+00 -25 0.00000e+00 2.50000e-01 0.00000e+00 -26 2.50000e-01 0.00000e+00 0.00000e+00 -27 9.08847e-02 2.54337e-01 0.00000e+00 -28 1.36272e-01 2.33380e-01 0.00000e+00 -29 4.57744e-02 2.75593e-01 0.00000e+00 -30 2.50000e-01 1.33975e-01 0.00000e+00 -31 2.25000e-01 1.77276e-01 0.00000e+00 -32 2.75000e-01 9.06733e-02 0.00000e+00 -33 2.00000e-01 2.20577e-01 0.00000e+00 -34 0.00000e+00 3.00000e-01 0.00000e+00 -35 3.00000e-01 0.00000e+00 0.00000e+00 -36 3.00000e-01 4.73721e-02 0.00000e+00 -37 8.62798e-02 3.03991e-01 0.00000e+00 -38 1.75000e-01 2.63878e-01 0.00000e+00 -39 1.41205e-01 2.94818e-01 0.00000e+00 -40 2.75000e-01 1.77276e-01 0.00000e+00 -41 4.33013e-02 3.25000e-01 0.00000e+00 -42 3.00000e-01 1.33975e-01 0.00000e+00 -43 2.50000e-01 2.20577e-01 0.00000e+00 -44 3.25000e-01 9.06733e-02 0.00000e+00 -45 2.25000e-01 2.63878e-01 0.00000e+00 -46 0.00000e+00 3.50000e-01 0.00000e+00 -47 3.50000e-01 0.00000e+00 0.00000e+00 -48 3.50000e-01 4.73721e-02 0.00000e+00 -49 7.50000e-02 3.50481e-01 0.00000e+00 -50 2.00000e-01 3.07180e-01 0.00000e+00 -51 1.21248e-01 3.47889e-01 0.00000e+00 -52 3.25000e-01 1.77276e-01 0.00000e+00 -53 3.00000e-01 2.20577e-01 0.00000e+00 -54 3.50000e-01 1.33975e-01 0.00000e+00 -55 4.33013e-02 3.75000e-01 0.00000e+00 -56 2.75000e-01 2.63878e-01 0.00000e+00 -57 3.75000e-01 9.06733e-02 0.00000e+00 -58 1.75000e-01 3.50481e-01 0.00000e+00 -59 2.50000e-01 3.07180e-01 0.00000e+00 -60 0.00000e+00 4.00000e-01 0.00000e+00 -61 4.00000e-01 0.00000e+00 0.00000e+00 -62 4.00000e-01 4.73721e-02 0.00000e+00 -63 1.00000e-01 3.93782e-01 0.00000e+00 -64 3.50000e-01 2.20577e-01 0.00000e+00 -65 3.75000e-01 1.77276e-01 0.00000e+00 -66 2.25000e-01 3.50481e-01 0.00000e+00 -67 3.25000e-01 2.63878e-01 0.00000e+00 -68 1.50000e-01 3.93782e-01 0.00000e+00 -69 4.00000e-01 1.33975e-01 0.00000e+00 -70 3.00000e-01 3.07180e-01 0.00000e+00 -71 4.25000e-01 9.06733e-02 0.00000e+00 -72 5.97573e-02 4.30948e-01 0.00000e+00 -73 2.00000e-01 3.93782e-01 0.00000e+00 -74 2.75000e-01 3.50481e-01 0.00000e+00 -75 0.00000e+00 4.50000e-01 0.00000e+00 -76 4.50000e-01 0.00000e+00 0.00000e+00 -77 4.50000e-01 4.73721e-02 0.00000e+00 -78 1.25000e-01 4.37083e-01 0.00000e+00 -79 4.00000e-01 2.20577e-01 0.00000e+00 -80 3.75000e-01 2.63878e-01 0.00000e+00 -81 4.25000e-01 1.77276e-01 0.00000e+00 -82 3.50000e-01 3.07180e-01 0.00000e+00 -83 2.50000e-01 3.93782e-01 0.00000e+00 -84 4.50000e-01 1.33975e-01 0.00000e+00 -85 1.75000e-01 4.37083e-01 0.00000e+00 -86 3.25000e-01 3.50481e-01 0.00000e+00 -87 4.40943e-02 4.77079e-01 0.00000e+00 -88 4.75000e-01 9.06733e-02 0.00000e+00 -89 1.00000e-01 4.80385e-01 0.00000e+00 -90 2.25000e-01 4.37083e-01 0.00000e+00 -91 3.00000e-01 3.93782e-01 0.00000e+00 -92 0.00000e+00 5.00000e-01 0.00000e+00 -93 5.00000e-01 0.00000e+00 0.00000e+00 -94 4.25000e-01 2.63878e-01 0.00000e+00 -95 4.50000e-01 2.20577e-01 0.00000e+00 -96 5.00000e-01 4.73721e-02 0.00000e+00 -97 1.50000e-01 4.80385e-01 0.00000e+00 -98 4.00000e-01 3.07180e-01 0.00000e+00 -99 4.75000e-01 1.77276e-01 0.00000e+00 -100 3.75000e-01 3.50481e-01 0.00000e+00 -101 2.75000e-01 4.37083e-01 0.00000e+00 -102 5.00000e-01 1.33975e-01 0.00000e+00 -103 2.00000e-01 4.80385e-01 0.00000e+00 -104 3.50000e-01 3.93782e-01 0.00000e+00 -105 6.07143e-02 5.24061e-01 0.00000e+00 -106 5.25000e-01 9.06733e-02 0.00000e+00 -107 1.25000e-01 5.23686e-01 0.00000e+00 -108 2.50000e-01 4.80385e-01 0.00000e+00 -109 4.75000e-01 2.63878e-01 0.00000e+00 -110 3.25000e-01 4.37083e-01 0.00000e+00 -111 4.50000e-01 3.07180e-01 0.00000e+00 -112 5.00000e-01 2.20577e-01 0.00000e+00 -113 0.00000e+00 5.50000e-01 0.00000e+00 -114 5.50000e-01 0.00000e+00 0.00000e+00 -115 4.25000e-01 3.50481e-01 0.00000e+00 -116 5.50000e-01 4.73721e-02 0.00000e+00 -117 1.75000e-01 5.23686e-01 0.00000e+00 -118 5.25000e-01 1.77276e-01 0.00000e+00 -119 4.00000e-01 3.93782e-01 0.00000e+00 -120 5.50000e-01 1.33975e-01 0.00000e+00 -121 3.00000e-01 4.80385e-01 0.00000e+00 -122 5.00000e-02 5.66987e-01 0.00000e+00 -123 2.25000e-01 5.23686e-01 0.00000e+00 -124 1.00000e-01 5.66987e-01 0.00000e+00 -125 3.75000e-01 4.37083e-01 0.00000e+00 -126 5.75000e-01 9.06733e-02 0.00000e+00 -127 1.50000e-01 5.66987e-01 0.00000e+00 -128 5.00000e-01 3.07180e-01 0.00000e+00 -129 5.25000e-01 2.63878e-01 0.00000e+00 -130 4.75000e-01 3.50481e-01 0.00000e+00 -131 2.75000e-01 5.23686e-01 0.00000e+00 -132 5.50000e-01 2.20577e-01 0.00000e+00 -133 3.50000e-01 4.80385e-01 0.00000e+00 -134 4.50000e-01 3.93782e-01 0.00000e+00 -135 0.00000e+00 6.00000e-01 0.00000e+00 -136 6.00000e-01 0.00000e+00 0.00000e+00 -137 2.00000e-01 5.66987e-01 0.00000e+00 -138 5.75000e-01 1.77276e-01 0.00000e+00 -139 6.00000e-01 4.73721e-02 0.00000e+00 -140 4.25000e-01 4.37083e-01 0.00000e+00 -141 7.08333e-02 6.08574e-01 0.00000e+00 -142 6.00000e-01 1.33975e-01 0.00000e+00 -143 3.25000e-01 5.23686e-01 0.00000e+00 -144 2.50000e-01 5.66987e-01 0.00000e+00 -145 1.25000e-01 6.10289e-01 0.00000e+00 -146 4.00000e-01 4.80385e-01 0.00000e+00 -147 5.50000e-01 3.07180e-01 0.00000e+00 -148 5.25000e-01 3.50481e-01 0.00000e+00 -149 6.25000e-01 9.06733e-02 0.00000e+00 -150 5.75000e-01 2.63878e-01 0.00000e+00 -151 1.75000e-01 6.10289e-01 0.00000e+00 -152 5.00000e-01 3.93782e-01 0.00000e+00 -153 6.00000e-01 2.20577e-01 0.00000e+00 -154 3.00000e-01 5.66987e-01 0.00000e+00 -155 3.75000e-01 5.23686e-01 0.00000e+00 -156 4.75000e-01 4.37083e-01 0.00000e+00 -157 6.25000e-01 1.77276e-01 0.00000e+00 -158 0.00000e+00 6.50000e-01 0.00000e+00 -159 6.50000e-01 0.00000e+00 0.00000e+00 -160 2.25000e-01 6.10289e-01 0.00000e+00 -161 5.00000e-02 6.53590e-01 0.00000e+00 -162 4.50000e-01 4.80385e-01 0.00000e+00 -163 1.00000e-01 6.53590e-01 0.00000e+00 -164 6.50000e-01 1.33975e-01 0.00000e+00 -165 3.50000e-01 5.66987e-01 0.00000e+00 -166 2.75000e-01 6.10289e-01 0.00000e+00 -167 1.50000e-01 6.53590e-01 0.00000e+00 -168 5.75000e-01 3.50481e-01 0.00000e+00 -169 6.00000e-01 3.07180e-01 0.00000e+00 -170 4.25000e-01 5.23686e-01 0.00000e+00 -171 6.75000e-01 4.33013e-02 0.00000e+00 -172 5.50000e-01 3.93782e-01 0.00000e+00 -173 6.25000e-01 2.63878e-01 0.00000e+00 -174 5.25000e-01 4.37083e-01 0.00000e+00 -175 2.00000e-01 6.53590e-01 0.00000e+00 -176 6.50000e-01 2.20577e-01 0.00000e+00 -177 3.25000e-01 6.10289e-01 0.00000e+00 -178 5.00000e-01 4.80385e-01 0.00000e+00 -179 4.00000e-01 5.66987e-01 0.00000e+00 -180 6.75000e-01 1.77276e-01 0.00000e+00 -181 2.50000e-01 6.53590e-01 0.00000e+00 -182 0.00000e+00 7.00000e-01 0.00000e+00 -183 7.00000e-01 0.00000e+00 0.00000e+00 -184 7.50000e-02 6.96891e-01 0.00000e+00 -185 7.00000e-01 8.66025e-02 0.00000e+00 -186 4.75000e-01 5.23686e-01 0.00000e+00 -187 1.25000e-01 6.96891e-01 0.00000e+00 -188 7.00000e-01 1.33975e-01 0.00000e+00 -189 3.75000e-01 6.10289e-01 0.00000e+00 -190 6.25000e-01 3.50481e-01 0.00000e+00 -191 6.00000e-01 3.93782e-01 0.00000e+00 -192 1.75000e-01 6.96891e-01 0.00000e+00 -193 6.50000e-01 3.07180e-01 0.00000e+00 -194 3.00000e-01 6.53590e-01 0.00000e+00 -195 5.75000e-01 4.37083e-01 0.00000e+00 -196 4.50000e-01 5.66987e-01 0.00000e+00 -197 6.75000e-01 2.63878e-01 0.00000e+00 -198 7.25000e-01 4.33013e-02 0.00000e+00 -199 5.50000e-01 4.80385e-01 0.00000e+00 -200 2.25000e-01 6.96891e-01 0.00000e+00 -201 7.00000e-01 2.20577e-01 0.00000e+00 -202 3.50000e-01 6.53590e-01 0.00000e+00 -203 5.25000e-01 5.23686e-01 0.00000e+00 -204 5.00000e-02 7.40192e-01 0.00000e+00 -205 4.25000e-01 6.10289e-01 0.00000e+00 -206 7.25000e-01 1.77276e-01 0.00000e+00 -207 1.00000e-01 7.40192e-01 0.00000e+00 -208 2.75000e-01 6.96891e-01 0.00000e+00 -209 0.00000e+00 7.50000e-01 0.00000e+00 -210 7.50000e-01 0.00000e+00 0.00000e+00 -211 7.50000e-01 8.66025e-02 0.00000e+00 -212 1.50000e-01 7.40192e-01 0.00000e+00 -213 5.00000e-01 5.66987e-01 0.00000e+00 -214 6.50000e-01 3.93782e-01 0.00000e+00 -215 6.75000e-01 3.50481e-01 0.00000e+00 -216 7.50000e-01 1.33975e-01 0.00000e+00 -217 6.25000e-01 4.37083e-01 0.00000e+00 -218 7.00000e-01 3.07180e-01 0.00000e+00 -219 4.00000e-01 6.53590e-01 0.00000e+00 -220 2.00000e-01 7.40192e-01 0.00000e+00 -221 6.00000e-01 4.80385e-01 0.00000e+00 -222 3.25000e-01 6.96891e-01 0.00000e+00 -223 7.25000e-01 2.63878e-01 0.00000e+00 -224 4.75000e-01 6.10289e-01 0.00000e+00 -225 7.75000e-01 4.33013e-02 0.00000e+00 -226 5.75000e-01 5.23686e-01 0.00000e+00 -227 2.50000e-01 7.40192e-01 0.00000e+00 -228 7.50000e-01 2.20577e-01 0.00000e+00 -229 7.08333e-02 7.86245e-01 0.00000e+00 -230 5.50000e-01 5.66987e-01 0.00000e+00 -231 3.75000e-01 6.96891e-01 0.00000e+00 -232 1.25000e-01 7.83494e-01 0.00000e+00 -233 4.50000e-01 6.53590e-01 0.00000e+00 -234 7.75000e-01 1.77276e-01 0.00000e+00 -235 3.00000e-01 7.40192e-01 0.00000e+00 -236 0.00000e+00 8.00000e-01 0.00000e+00 -237 8.00000e-01 0.00000e+00 0.00000e+00 -238 1.75000e-01 7.83494e-01 0.00000e+00 -239 7.00000e-01 3.93782e-01 0.00000e+00 -240 6.75000e-01 4.37083e-01 0.00000e+00 -241 8.00000e-01 8.66025e-02 0.00000e+00 -242 5.25000e-01 6.10289e-01 0.00000e+00 -243 7.25000e-01 3.50481e-01 0.00000e+00 -244 6.50000e-01 4.80385e-01 0.00000e+00 -245 7.50000e-01 3.07180e-01 0.00000e+00 -246 8.00000e-01 1.33975e-01 0.00000e+00 -247 2.25000e-01 7.83494e-01 0.00000e+00 -248 6.25000e-01 5.23686e-01 0.00000e+00 -249 4.25000e-01 6.96891e-01 0.00000e+00 -250 7.75000e-01 2.63878e-01 0.00000e+00 -251 3.50000e-01 7.40192e-01 0.00000e+00 -252 5.00000e-01 6.53590e-01 0.00000e+00 -253 6.00000e-01 5.66987e-01 0.00000e+00 -254 8.25000e-01 4.33013e-02 0.00000e+00 -255 4.63095e-02 8.26907e-01 0.00000e+00 -256 8.00000e-01 2.20577e-01 0.00000e+00 -257 2.75000e-01 7.83494e-01 0.00000e+00 -258 1.00000e-01 8.26795e-01 0.00000e+00 -259 5.75000e-01 6.10289e-01 0.00000e+00 -260 1.50000e-01 8.26795e-01 0.00000e+00 -261 4.00000e-01 7.40192e-01 0.00000e+00 -262 4.75000e-01 6.96891e-01 0.00000e+00 -263 8.25000e-01 1.77276e-01 0.00000e+00 -264 7.25000e-01 4.37083e-01 0.00000e+00 -265 7.50000e-01 3.93782e-01 0.00000e+00 -266 3.25000e-01 7.83494e-01 0.00000e+00 -267 7.00000e-01 4.80385e-01 0.00000e+00 -268 0.00000e+00 8.50000e-01 0.00000e+00 -269 8.50000e-01 0.00000e+00 0.00000e+00 -270 7.75000e-01 3.50481e-01 0.00000e+00 -271 2.00000e-01 8.26795e-01 0.00000e+00 -272 5.50000e-01 6.53590e-01 0.00000e+00 -273 6.75000e-01 5.23686e-01 0.00000e+00 -274 8.00000e-01 3.07180e-01 0.00000e+00 -275 8.50000e-01 1.33975e-01 0.00000e+00 -276 6.50000e-01 5.66987e-01 0.00000e+00 -277 2.50000e-01 8.26795e-01 0.00000e+00 -278 8.25000e-01 2.63878e-01 0.00000e+00 -279 4.50000e-01 7.40192e-01 0.00000e+00 -280 3.75000e-01 7.83494e-01 0.00000e+00 -281 5.25000e-01 6.96891e-01 0.00000e+00 -282 6.25000e-01 6.10289e-01 0.00000e+00 -283 6.07143e-02 8.71497e-01 0.00000e+00 -284 8.75000e-01 4.33013e-02 0.00000e+00 -285 8.50000e-01 2.20577e-01 0.00000e+00 -286 1.25000e-01 8.70096e-01 0.00000e+00 -287 3.00000e-01 8.26795e-01 0.00000e+00 -288 8.75000e-01 9.06733e-02 0.00000e+00 -289 6.00000e-01 6.53590e-01 0.00000e+00 -290 1.75000e-01 8.70096e-01 0.00000e+00 -291 7.75000e-01 4.37083e-01 0.00000e+00 -292 7.50000e-01 4.80385e-01 0.00000e+00 -293 4.25000e-01 7.83494e-01 0.00000e+00 -294 8.00000e-01 3.93782e-01 0.00000e+00 -295 8.75000e-01 1.77276e-01 0.00000e+00 -296 5.00000e-01 7.40192e-01 0.00000e+00 -297 7.25000e-01 5.23686e-01 0.00000e+00 -298 8.25000e-01 3.50481e-01 0.00000e+00 -299 3.50000e-01 8.26795e-01 0.00000e+00 -300 2.25000e-01 8.70096e-01 0.00000e+00 -301 0.00000e+00 9.00000e-01 0.00000e+00 -302 9.00000e-01 0.00000e+00 0.00000e+00 -303 7.00000e-01 5.66987e-01 0.00000e+00 -304 5.75000e-01 6.96891e-01 0.00000e+00 -305 8.50000e-01 3.07180e-01 0.00000e+00 -306 9.00000e-01 1.33975e-01 0.00000e+00 -307 6.75000e-01 6.10289e-01 0.00000e+00 -308 2.75000e-01 8.70096e-01 0.00000e+00 -309 8.75000e-01 2.63878e-01 0.00000e+00 -310 5.00000e-02 9.13397e-01 0.00000e+00 -311 4.75000e-01 7.83494e-01 0.00000e+00 -312 4.00000e-01 8.26795e-01 0.00000e+00 -313 1.00000e-01 9.13397e-01 0.00000e+00 -314 6.50000e-01 6.53590e-01 0.00000e+00 -315 5.50000e-01 7.40192e-01 0.00000e+00 -316 1.50000e-01 9.13397e-01 0.00000e+00 -317 9.25000e-01 4.33013e-02 0.00000e+00 -318 9.00000e-01 2.20577e-01 0.00000e+00 -319 3.25000e-01 8.70096e-01 0.00000e+00 -320 9.25000e-01 9.06733e-02 0.00000e+00 -321 8.00000e-01 4.80385e-01 0.00000e+00 -322 8.25000e-01 4.37083e-01 0.00000e+00 -323 2.00000e-01 9.13397e-01 0.00000e+00 -324 7.75000e-01 5.23686e-01 0.00000e+00 -325 6.25000e-01 6.96891e-01 0.00000e+00 -326 8.50000e-01 3.93782e-01 0.00000e+00 -327 7.50000e-01 5.66987e-01 0.00000e+00 -328 4.50000e-01 8.26795e-01 0.00000e+00 -329 9.25000e-01 1.77276e-01 0.00000e+00 -330 8.75000e-01 3.50481e-01 0.00000e+00 -331 5.25000e-01 7.83494e-01 0.00000e+00 -332 2.50000e-01 9.13397e-01 0.00000e+00 -333 3.75000e-01 8.70096e-01 0.00000e+00 -334 7.25000e-01 6.10289e-01 0.00000e+00 -335 0.00000e+00 9.50000e-01 0.00000e+00 -336 9.50000e-01 0.00000e+00 0.00000e+00 -337 9.00000e-01 3.07180e-01 0.00000e+00 -338 6.00000e-01 7.40192e-01 0.00000e+00 -339 7.00000e-01 6.53590e-01 0.00000e+00 -340 7.08333e-02 9.55582e-01 0.00000e+00 -341 3.00000e-01 9.13397e-01 0.00000e+00 -342 9.25000e-01 2.63878e-01 0.00000e+00 -343 1.25000e-01 9.56699e-01 0.00000e+00 -344 5.00000e-01 8.26795e-01 0.00000e+00 -345 9.59757e-01 1.23242e-01 0.00000e+00 -346 4.25000e-01 8.70096e-01 0.00000e+00 -347 6.75000e-01 6.96891e-01 0.00000e+00 -348 9.68301e-01 6.69873e-02 0.00000e+00 -349 5.75000e-01 7.83494e-01 0.00000e+00 -350 1.75000e-01 9.56699e-01 0.00000e+00 -351 9.50000e-01 2.20577e-01 0.00000e+00 -352 8.50000e-01 4.80385e-01 0.00000e+00 -353 8.25000e-01 5.23686e-01 0.00000e+00 -354 8.75000e-01 4.37083e-01 0.00000e+00 -355 3.50000e-01 9.13397e-01 0.00000e+00 -356 8.00000e-01 5.66987e-01 0.00000e+00 -357 9.00000e-01 3.93782e-01 0.00000e+00 -358 2.25000e-01 9.56699e-01 0.00000e+00 -359 6.50000e-01 7.40192e-01 0.00000e+00 -360 7.75000e-01 6.10289e-01 0.00000e+00 -361 9.25000e-01 3.50481e-01 0.00000e+00 -362 9.75000e-01 1.77276e-01 0.00000e+00 -363 4.75000e-01 8.70096e-01 0.00000e+00 -364 5.50000e-01 8.26795e-01 0.00000e+00 -365 7.50000e-01 6.53590e-01 0.00000e+00 -366 2.75000e-01 9.56699e-01 0.00000e+00 -367 4.00000e-01 9.13397e-01 0.00000e+00 -368 9.50000e-01 3.07180e-01 0.00000e+00 -369 0.00000e+00 1.00000e+00 0.00000e+00 -370 1.00000e+00 0.00000e+00 0.00000e+00 -371 5.00000e-02 1.00000e+00 0.00000e+00 -372 6.25000e-01 7.83494e-01 0.00000e+00 -373 1.00000e-01 1.00000e+00 0.00000e+00 -374 7.25000e-01 6.96891e-01 0.00000e+00 -375 1.00561e+00 9.00074e-02 0.00000e+00 -376 9.75000e-01 2.63878e-01 0.00000e+00 -377 3.25000e-01 9.56699e-01 0.00000e+00 -378 1.50000e-01 1.00000e+00 0.00000e+00 -379 5.25000e-01 8.70096e-01 0.00000e+00 -380 4.50000e-01 9.13397e-01 0.00000e+00 -381 7.00000e-01 7.40192e-01 0.00000e+00 -382 8.75000e-01 5.23686e-01 0.00000e+00 -383 2.00000e-01 1.00000e+00 0.00000e+00 -384 9.00000e-01 4.80385e-01 0.00000e+00 -385 6.00000e-01 8.26795e-01 0.00000e+00 -386 8.50000e-01 5.66987e-01 0.00000e+00 -387 9.25000e-01 4.37083e-01 0.00000e+00 -388 1.00000e+00 2.20577e-01 0.00000e+00 -389 1.02500e+00 4.33013e-02 0.00000e+00 -390 8.25000e-01 6.10289e-01 0.00000e+00 -391 3.75000e-01 9.56699e-01 0.00000e+00 -392 9.50000e-01 3.93782e-01 0.00000e+00 -393 2.50000e-01 1.00000e+00 0.00000e+00 -394 8.00000e-01 6.53590e-01 0.00000e+00 -395 1.02500e+00 1.29904e-01 0.00000e+00 -396 6.75000e-01 7.83494e-01 0.00000e+00 -397 9.75000e-01 3.50481e-01 0.00000e+00 -398 5.00000e-01 9.13397e-01 0.00000e+00 -399 7.75000e-01 6.96891e-01 0.00000e+00 -400 5.75000e-01 8.70096e-01 0.00000e+00 -401 3.00000e-01 1.00000e+00 0.00000e+00 -402 1.00000e+00 3.07180e-01 0.00000e+00 -403 4.25000e-01 9.56699e-01 0.00000e+00 -404 1.05000e+00 0.00000e+00 0.00000e+00 -405 6.50000e-01 8.26795e-01 0.00000e+00 -406 1.05000e+00 8.66025e-02 0.00000e+00 -407 7.50000e-01 7.40192e-01 0.00000e+00 -408 1.02500e+00 2.63878e-01 0.00000e+00 -409 3.50000e-01 1.00000e+00 0.00000e+00 -410 9.25000e-01 5.23686e-01 0.00000e+00 -411 9.00000e-01 5.66987e-01 0.00000e+00 -412 1.05000e+00 1.73205e-01 0.00000e+00 -413 9.50000e-01 4.80385e-01 0.00000e+00 -414 5.50000e-01 9.13397e-01 0.00000e+00 -415 8.75000e-01 6.10289e-01 0.00000e+00 -416 7.25000e-01 7.83494e-01 0.00000e+00 -417 4.75000e-01 9.56699e-01 0.00000e+00 -418 9.75000e-01 4.37083e-01 0.00000e+00 -419 6.25000e-01 8.70096e-01 0.00000e+00 -420 8.50000e-01 6.53590e-01 0.00000e+00 -421 1.00000e+00 3.93782e-01 0.00000e+00 -422 1.07500e+00 4.33013e-02 0.00000e+00 -423 4.00000e-01 1.00000e+00 0.00000e+00 -424 8.25000e-01 6.96891e-01 0.00000e+00 -425 1.07500e+00 1.29904e-01 0.00000e+00 -426 1.02500e+00 3.50481e-01 0.00000e+00 -427 7.00000e-01 8.26795e-01 0.00000e+00 -428 8.00000e-01 7.40192e-01 0.00000e+00 -429 5.25000e-01 9.56699e-01 0.00000e+00 -430 6.00000e-01 9.13397e-01 0.00000e+00 -431 1.05000e+00 3.07180e-01 0.00000e+00 -432 1.07500e+00 2.16506e-01 0.00000e+00 -433 4.50000e-01 1.00000e+00 0.00000e+00 -434 1.10000e+00 0.00000e+00 0.00000e+00 -435 6.75000e-01 8.70096e-01 0.00000e+00 -436 7.75000e-01 7.83494e-01 0.00000e+00 -437 1.10000e+00 8.66025e-02 0.00000e+00 -438 9.50000e-01 5.66987e-01 0.00000e+00 -439 9.75000e-01 5.23686e-01 0.00000e+00 -440 9.25000e-01 6.10289e-01 0.00000e+00 -441 1.00000e+00 4.80385e-01 0.00000e+00 -442 9.00000e-01 6.53590e-01 0.00000e+00 -443 1.10000e+00 1.73205e-01 0.00000e+00 -444 1.02500e+00 4.37083e-01 0.00000e+00 -445 5.75000e-01 9.56699e-01 0.00000e+00 -446 7.50000e-01 8.26795e-01 0.00000e+00 -447 5.00000e-01 1.00000e+00 0.00000e+00 -448 8.75000e-01 6.96891e-01 0.00000e+00 -449 6.50000e-01 9.13397e-01 0.00000e+00 -450 1.05000e+00 3.93782e-01 0.00000e+00 -451 1.12500e+00 4.33013e-02 0.00000e+00 -452 8.50000e-01 7.40192e-01 0.00000e+00 -453 1.10000e+00 2.59808e-01 0.00000e+00 -454 1.07500e+00 3.50481e-01 0.00000e+00 -455 1.12500e+00 1.29904e-01 0.00000e+00 -456 7.25000e-01 8.70096e-01 0.00000e+00 -457 8.25000e-01 7.83494e-01 0.00000e+00 -458 5.50000e-01 1.00000e+00 0.00000e+00 -459 6.25000e-01 9.56699e-01 0.00000e+00 -460 1.12500e+00 2.16506e-01 0.00000e+00 -461 1.00000e+00 5.66987e-01 0.00000e+00 -462 1.15000e+00 0.00000e+00 0.00000e+00 -463 9.75000e-01 6.10289e-01 0.00000e+00 -464 8.00000e-01 8.26795e-01 0.00000e+00 -465 7.00000e-01 9.13397e-01 0.00000e+00 -466 1.02500e+00 5.23686e-01 0.00000e+00 -467 9.50000e-01 6.53590e-01 0.00000e+00 -468 1.15000e+00 8.66025e-02 0.00000e+00 -469 1.05000e+00 4.80385e-01 0.00000e+00 -470 9.25000e-01 6.96891e-01 0.00000e+00 -471 1.07500e+00 4.37083e-01 0.00000e+00 -472 1.15000e+00 1.73205e-01 0.00000e+00 -473 1.12500e+00 3.03109e-01 0.00000e+00 -474 7.75000e-01 8.70096e-01 0.00000e+00 -475 9.00000e-01 7.40192e-01 0.00000e+00 -476 6.00000e-01 1.00000e+00 0.00000e+00 -477 6.75000e-01 9.56699e-01 0.00000e+00 -478 8.75000e-01 7.83494e-01 0.00000e+00 -479 1.17500e+00 4.33013e-02 0.00000e+00 -480 1.15000e+00 2.59808e-01 0.00000e+00 -481 7.50000e-01 9.13397e-01 0.00000e+00 -482 1.17500e+00 1.29904e-01 0.00000e+00 -483 8.50000e-01 8.26795e-01 0.00000e+00 -484 1.12500e+00 3.89711e-01 0.00000e+00 -485 6.50000e-01 1.00000e+00 0.00000e+00 -486 1.02500e+00 6.10289e-01 0.00000e+00 -487 1.05000e+00 5.66987e-01 0.00000e+00 -488 1.00000e+00 6.53590e-01 0.00000e+00 -489 1.17500e+00 2.16506e-01 0.00000e+00 -490 1.07500e+00 5.23686e-01 0.00000e+00 -491 9.75000e-01 6.96891e-01 0.00000e+00 -492 8.25000e-01 8.70096e-01 0.00000e+00 -493 1.20000e+00 0.00000e+00 0.00000e+00 -494 1.10000e+00 4.80385e-01 0.00000e+00 -495 7.25000e-01 9.56699e-01 0.00000e+00 -496 1.15000e+00 3.46410e-01 0.00000e+00 -497 1.20000e+00 8.66025e-02 0.00000e+00 -498 9.50000e-01 7.40192e-01 0.00000e+00 -499 9.25000e-01 7.83494e-01 0.00000e+00 -500 1.20000e+00 1.73205e-01 0.00000e+00 -501 1.17500e+00 3.03109e-01 0.00000e+00 -502 8.00000e-01 9.13397e-01 0.00000e+00 -503 7.00000e-01 1.00000e+00 0.00000e+00 -504 9.00000e-01 8.26795e-01 0.00000e+00 -505 1.22500e+00 4.33013e-02 0.00000e+00 -506 1.20000e+00 2.59808e-01 0.00000e+00 -507 1.15000e+00 4.33013e-01 0.00000e+00 -508 7.75000e-01 9.56699e-01 0.00000e+00 -509 1.22500e+00 1.29904e-01 0.00000e+00 -510 8.75000e-01 8.70096e-01 0.00000e+00 -511 1.07500e+00 6.10289e-01 0.00000e+00 -512 1.05000e+00 6.53590e-01 0.00000e+00 -513 1.10000e+00 5.66987e-01 0.00000e+00 -514 1.17500e+00 3.89711e-01 0.00000e+00 -515 1.02500e+00 6.96891e-01 0.00000e+00 -516 1.12500e+00 5.23686e-01 0.00000e+00 -517 1.22500e+00 2.16506e-01 0.00000e+00 -518 1.00000e+00 7.40192e-01 0.00000e+00 -519 1.15000e+00 4.80385e-01 0.00000e+00 -520 8.50000e-01 9.13397e-01 0.00000e+00 -521 1.20000e+00 3.46410e-01 0.00000e+00 -522 7.50000e-01 1.00000e+00 0.00000e+00 -523 1.25000e+00 0.00000e+00 0.00000e+00 -524 9.75000e-01 7.83494e-01 0.00000e+00 -525 1.25000e+00 8.66025e-02 0.00000e+00 -526 9.50000e-01 8.26795e-01 0.00000e+00 -527 1.22500e+00 3.03109e-01 0.00000e+00 -528 1.25000e+00 1.73205e-01 0.00000e+00 -529 8.25000e-01 9.56699e-01 0.00000e+00 -530 9.25000e-01 8.70096e-01 0.00000e+00 -531 1.20000e+00 4.33013e-01 0.00000e+00 -532 1.27500e+00 4.33013e-02 0.00000e+00 -533 1.25000e+00 2.59808e-01 0.00000e+00 -534 1.10000e+00 6.53590e-01 0.00000e+00 -535 1.12500e+00 6.10289e-01 0.00000e+00 -536 8.00000e-01 1.00000e+00 0.00000e+00 -537 1.07500e+00 6.96891e-01 0.00000e+00 -538 1.27500e+00 1.29904e-01 0.00000e+00 -539 1.15000e+00 5.66987e-01 0.00000e+00 -540 9.00000e-01 9.13397e-01 0.00000e+00 -541 1.05000e+00 7.40192e-01 0.00000e+00 -542 1.22500e+00 3.89711e-01 0.00000e+00 -543 1.17500e+00 5.23686e-01 0.00000e+00 -544 1.02500e+00 7.83494e-01 0.00000e+00 -545 1.20000e+00 4.80385e-01 0.00000e+00 -546 1.27500e+00 2.16506e-01 0.00000e+00 -547 8.75000e-01 9.56699e-01 0.00000e+00 -548 1.25000e+00 3.46410e-01 0.00000e+00 -549 1.00000e+00 8.26795e-01 0.00000e+00 -550 1.30000e+00 0.00000e+00 0.00000e+00 -551 1.30000e+00 8.66025e-02 0.00000e+00 -552 9.75000e-01 8.70096e-01 0.00000e+00 -553 1.27500e+00 3.03109e-01 0.00000e+00 -554 1.30000e+00 1.73205e-01 0.00000e+00 -555 8.50000e-01 1.00000e+00 0.00000e+00 -556 9.50000e-01 9.13397e-01 0.00000e+00 -557 1.15000e+00 6.53590e-01 0.00000e+00 -558 1.25000e+00 4.33013e-01 0.00000e+00 -559 1.12500e+00 6.96891e-01 0.00000e+00 -560 1.17500e+00 6.10289e-01 0.00000e+00 -561 1.30000e+00 2.59808e-01 0.00000e+00 -562 1.32500e+00 4.33013e-02 0.00000e+00 -563 1.10000e+00 7.40192e-01 0.00000e+00 -564 1.20000e+00 5.66987e-01 0.00000e+00 -565 1.07500e+00 7.83494e-01 0.00000e+00 -566 9.25000e-01 9.56699e-01 0.00000e+00 -567 1.32500e+00 1.29904e-01 0.00000e+00 -568 1.22500e+00 5.23686e-01 0.00000e+00 -569 1.27500e+00 3.89711e-01 0.00000e+00 -570 1.05000e+00 8.26795e-01 0.00000e+00 -571 1.25000e+00 4.80385e-01 0.00000e+00 -572 1.32500e+00 2.16506e-01 0.00000e+00 -573 1.02500e+00 8.70096e-01 0.00000e+00 -574 1.30000e+00 3.46410e-01 0.00000e+00 -575 9.00000e-01 1.00000e+00 0.00000e+00 -576 1.35000e+00 0.00000e+00 0.00000e+00 -577 1.35000e+00 8.66025e-02 0.00000e+00 -578 1.00000e+00 9.13397e-01 0.00000e+00 -579 1.32500e+00 3.03109e-01 0.00000e+00 -580 1.35000e+00 1.73205e-01 0.00000e+00 -581 9.75000e-01 9.56699e-01 0.00000e+00 -582 1.17500e+00 6.96891e-01 0.00000e+00 -583 1.20000e+00 6.53590e-01 0.00000e+00 -584 1.15000e+00 7.40192e-01 0.00000e+00 -585 1.22500e+00 6.10289e-01 0.00000e+00 -586 1.12500e+00 7.83494e-01 0.00000e+00 -587 1.25000e+00 5.66987e-01 0.00000e+00 -588 1.35000e+00 2.59808e-01 0.00000e+00 -589 1.37500e+00 4.33013e-02 0.00000e+00 -590 1.10000e+00 8.26795e-01 0.00000e+00 -591 1.27500e+00 5.23686e-01 0.00000e+00 -592 9.50000e-01 1.00000e+00 0.00000e+00 -593 1.32500e+00 3.89711e-01 0.00000e+00 -594 1.37500e+00 1.29904e-01 0.00000e+00 -595 1.07500e+00 8.70096e-01 0.00000e+00 -596 1.30000e+00 4.80385e-01 0.00000e+00 -597 1.05000e+00 9.13397e-01 0.00000e+00 -598 1.37500e+00 2.16506e-01 0.00000e+00 -599 1.35000e+00 3.46410e-01 0.00000e+00 -600 1.32500e+00 4.37083e-01 0.00000e+00 -601 1.40000e+00 0.00000e+00 0.00000e+00 -602 1.02500e+00 9.56699e-01 0.00000e+00 -603 1.40000e+00 8.66025e-02 0.00000e+00 -604 1.37500e+00 3.03109e-01 0.00000e+00 -605 1.22500e+00 6.96891e-01 0.00000e+00 -606 1.20000e+00 7.40192e-01 0.00000e+00 -607 1.25000e+00 6.53590e-01 0.00000e+00 -608 1.40000e+00 1.73205e-01 0.00000e+00 -609 1.17500e+00 7.83494e-01 0.00000e+00 -610 1.27500e+00 6.10289e-01 0.00000e+00 -611 1.00000e+00 1.00000e+00 0.00000e+00 -612 1.15000e+00 8.26795e-01 0.00000e+00 -613 1.30000e+00 5.66987e-01 0.00000e+00 -614 1.12500e+00 8.70096e-01 0.00000e+00 -615 1.40000e+00 2.59808e-01 0.00000e+00 -616 1.32500e+00 5.23686e-01 0.00000e+00 -617 1.42500e+00 4.33013e-02 0.00000e+00 -618 1.37500e+00 3.89711e-01 0.00000e+00 -619 1.10000e+00 9.13397e-01 0.00000e+00 -620 1.42500e+00 1.29904e-01 0.00000e+00 -621 1.35000e+00 4.80385e-01 0.00000e+00 -622 1.07500e+00 9.56699e-01 0.00000e+00 -623 1.42500e+00 2.16506e-01 0.00000e+00 -624 1.40000e+00 3.46410e-01 0.00000e+00 -625 1.37500e+00 4.37083e-01 0.00000e+00 -626 1.05000e+00 1.00000e+00 0.00000e+00 -627 1.45000e+00 0.00000e+00 0.00000e+00 -628 1.45000e+00 8.66025e-02 0.00000e+00 -629 1.25000e+00 7.40192e-01 0.00000e+00 -630 1.27500e+00 6.96891e-01 0.00000e+00 -631 1.22500e+00 7.83494e-01 0.00000e+00 -632 1.30000e+00 6.53590e-01 0.00000e+00 -633 1.42500e+00 3.03109e-01 0.00000e+00 -634 1.20000e+00 8.26795e-01 0.00000e+00 -635 1.32500e+00 6.10289e-01 0.00000e+00 -636 1.45000e+00 1.73205e-01 0.00000e+00 -637 1.17500e+00 8.70096e-01 0.00000e+00 -638 1.35000e+00 5.66987e-01 0.00000e+00 -639 1.15000e+00 9.13397e-01 0.00000e+00 -640 1.37500e+00 5.23686e-01 0.00000e+00 -641 1.45000e+00 2.59808e-01 0.00000e+00 -642 1.47500e+00 4.33013e-02 0.00000e+00 -643 1.12500e+00 9.56699e-01 0.00000e+00 -644 1.42500e+00 3.89711e-01 0.00000e+00 -645 1.40000e+00 4.80385e-01 0.00000e+00 -646 1.47500e+00 1.29904e-01 0.00000e+00 -647 1.10000e+00 1.00000e+00 0.00000e+00 -648 1.42500e+00 4.37083e-01 0.00000e+00 -649 1.45000e+00 3.46410e-01 0.00000e+00 -650 1.47500e+00 2.16506e-01 0.00000e+00 -651 1.30000e+00 7.40192e-01 0.00000e+00 -652 1.27500e+00 7.83494e-01 0.00000e+00 -653 1.32500e+00 6.96891e-01 0.00000e+00 -654 1.25000e+00 8.26795e-01 0.00000e+00 -655 1.35000e+00 6.53590e-01 0.00000e+00 -656 1.50000e+00 0.00000e+00 0.00000e+00 -657 1.50000e+00 8.66025e-02 0.00000e+00 -658 1.22500e+00 8.70096e-01 0.00000e+00 -659 1.37500e+00 6.10289e-01 0.00000e+00 -660 1.47500e+00 3.03109e-01 0.00000e+00 -661 1.20000e+00 9.13397e-01 0.00000e+00 -662 1.50000e+00 1.73205e-01 0.00000e+00 -663 1.40000e+00 5.66987e-01 0.00000e+00 -664 1.17500e+00 9.56699e-01 0.00000e+00 -665 1.42500e+00 5.23686e-01 0.00000e+00 -666 1.50000e+00 2.59808e-01 0.00000e+00 -667 1.15000e+00 1.00000e+00 0.00000e+00 -668 1.47500e+00 3.89711e-01 0.00000e+00 -669 1.52500e+00 4.33013e-02 0.00000e+00 -670 1.45000e+00 4.80385e-01 0.00000e+00 -671 1.52500e+00 1.29904e-01 0.00000e+00 -672 1.47500e+00 4.37083e-01 0.00000e+00 -673 1.32500e+00 7.83494e-01 0.00000e+00 -674 1.50000e+00 3.46410e-01 0.00000e+00 -675 1.35000e+00 7.40192e-01 0.00000e+00 -676 1.52500e+00 2.16506e-01 0.00000e+00 -677 1.30000e+00 8.26795e-01 0.00000e+00 -678 1.37500e+00 6.96891e-01 0.00000e+00 -679 1.27500e+00 8.70096e-01 0.00000e+00 -680 1.40000e+00 6.53590e-01 0.00000e+00 -681 1.25000e+00 9.13397e-01 0.00000e+00 -682 1.55000e+00 0.00000e+00 0.00000e+00 -683 1.42500e+00 6.10289e-01 0.00000e+00 -684 1.55000e+00 8.66025e-02 0.00000e+00 -685 1.22500e+00 9.56699e-01 0.00000e+00 -686 1.52500e+00 3.03109e-01 0.00000e+00 -687 1.45000e+00 5.66987e-01 0.00000e+00 -688 1.55000e+00 1.73205e-01 0.00000e+00 -689 1.20000e+00 1.00000e+00 0.00000e+00 -690 1.47500e+00 5.23686e-01 0.00000e+00 -691 1.55000e+00 2.59808e-01 0.00000e+00 -692 1.50000e+00 4.80385e-01 0.00000e+00 -693 1.57500e+00 4.33013e-02 0.00000e+00 -694 1.57500e+00 1.29904e-01 0.00000e+00 -695 1.37500e+00 7.83494e-01 0.00000e+00 -696 1.35000e+00 8.26795e-01 0.00000e+00 -697 1.40000e+00 7.40192e-01 0.00000e+00 -698 1.32500e+00 8.70096e-01 0.00000e+00 -699 1.42500e+00 6.96891e-01 0.00000e+00 -700 1.52500e+00 4.37083e-01 0.00000e+00 -701 1.30000e+00 9.13397e-01 0.00000e+00 -702 1.57500e+00 2.16506e-01 0.00000e+00 -703 1.45000e+00 6.53590e-01 0.00000e+00 -704 1.27500e+00 9.56699e-01 0.00000e+00 -705 1.47500e+00 6.10289e-01 0.00000e+00 -706 1.55000e+00 3.93782e-01 0.00000e+00 -707 1.60000e+00 0.00000e+00 0.00000e+00 -708 1.25000e+00 1.00000e+00 0.00000e+00 -709 1.60000e+00 8.66025e-02 0.00000e+00 -710 1.50000e+00 5.66987e-01 0.00000e+00 -711 1.57500e+00 3.03109e-01 0.00000e+00 -712 1.60000e+00 1.73205e-01 0.00000e+00 -713 1.52500e+00 5.23686e-01 0.00000e+00 -714 1.57500e+00 3.50481e-01 0.00000e+00 -715 1.60000e+00 2.59808e-01 0.00000e+00 -716 1.55000e+00 4.80385e-01 0.00000e+00 -717 1.62500e+00 4.33013e-02 0.00000e+00 -718 1.40000e+00 8.26795e-01 0.00000e+00 -719 1.42500e+00 7.83494e-01 0.00000e+00 -720 1.37500e+00 8.70096e-01 0.00000e+00 -721 1.45000e+00 7.40192e-01 0.00000e+00 -722 1.35000e+00 9.13397e-01 0.00000e+00 -723 1.62500e+00 1.29904e-01 0.00000e+00 -724 1.47500e+00 6.96891e-01 0.00000e+00 -725 1.32500e+00 9.56699e-01 0.00000e+00 -726 1.57500e+00 4.37083e-01 0.00000e+00 -727 1.50000e+00 6.53590e-01 0.00000e+00 -728 1.62500e+00 2.16506e-01 0.00000e+00 -729 1.30000e+00 1.00000e+00 0.00000e+00 -730 1.52500e+00 6.10289e-01 0.00000e+00 -731 1.60000e+00 3.93782e-01 0.00000e+00 -732 1.65000e+00 0.00000e+00 0.00000e+00 -733 1.55000e+00 5.66987e-01 0.00000e+00 -734 1.65000e+00 8.66025e-02 0.00000e+00 -735 1.62500e+00 3.03109e-01 0.00000e+00 -736 1.65000e+00 1.73205e-01 0.00000e+00 -737 1.57500e+00 5.23686e-01 0.00000e+00 -738 1.45000e+00 8.26795e-01 0.00000e+00 -739 1.42500e+00 8.70096e-01 0.00000e+00 -740 1.47500e+00 7.83494e-01 0.00000e+00 -741 1.65000e+00 2.59808e-01 0.00000e+00 -742 1.60000e+00 4.80385e-01 0.00000e+00 -743 1.40000e+00 9.13397e-01 0.00000e+00 -744 1.50000e+00 7.40192e-01 0.00000e+00 -745 1.37500e+00 9.56699e-01 0.00000e+00 -746 1.67500e+00 4.33013e-02 0.00000e+00 -747 1.52500e+00 6.96891e-01 0.00000e+00 -748 1.35000e+00 1.00000e+00 0.00000e+00 -749 1.67500e+00 1.29904e-01 0.00000e+00 -750 1.55000e+00 6.53590e-01 0.00000e+00 -751 1.62500e+00 4.37083e-01 0.00000e+00 -752 1.65000e+00 3.46410e-01 0.00000e+00 -753 1.67500e+00 2.16506e-01 0.00000e+00 -754 1.57500e+00 6.10289e-01 0.00000e+00 -755 1.65000e+00 3.93782e-01 0.00000e+00 -756 1.60000e+00 5.66987e-01 0.00000e+00 -757 1.70000e+00 0.00000e+00 0.00000e+00 -758 1.70000e+00 8.66025e-02 0.00000e+00 -759 1.67500e+00 3.03109e-01 0.00000e+00 -760 1.62500e+00 5.23686e-01 0.00000e+00 -761 1.70000e+00 1.73205e-01 0.00000e+00 -762 1.47500e+00 8.70096e-01 0.00000e+00 -763 1.50000e+00 8.26795e-01 0.00000e+00 -764 1.45000e+00 9.13397e-01 0.00000e+00 -765 1.52500e+00 7.83494e-01 0.00000e+00 -766 1.42500e+00 9.56699e-01 0.00000e+00 -767 1.55000e+00 7.40192e-01 0.00000e+00 -768 1.65000e+00 4.80385e-01 0.00000e+00 -769 1.70000e+00 2.59808e-01 0.00000e+00 -770 1.40000e+00 1.00000e+00 0.00000e+00 -771 1.57500e+00 6.96891e-01 0.00000e+00 -772 1.72500e+00 4.33013e-02 0.00000e+00 -773 1.60000e+00 6.53590e-01 0.00000e+00 -774 1.72500e+00 1.29904e-01 0.00000e+00 -775 1.67500e+00 4.37083e-01 0.00000e+00 -776 1.70000e+00 3.46410e-01 0.00000e+00 -777 1.62500e+00 6.10289e-01 0.00000e+00 -778 1.72500e+00 2.16506e-01 0.00000e+00 -779 1.65000e+00 5.66987e-01 0.00000e+00 -780 1.70000e+00 3.93782e-01 0.00000e+00 -781 1.75000e+00 0.00000e+00 0.00000e+00 -782 1.72500e+00 3.03109e-01 0.00000e+00 -783 1.75000e+00 8.66025e-02 0.00000e+00 -784 1.67500e+00 5.23686e-01 0.00000e+00 -785 1.52500e+00 8.70096e-01 0.00000e+00 -786 1.50000e+00 9.13397e-01 0.00000e+00 -787 1.55000e+00 8.26795e-01 0.00000e+00 -788 1.47500e+00 9.56699e-01 0.00000e+00 -789 1.75000e+00 1.73205e-01 0.00000e+00 -790 1.57500e+00 7.83494e-01 0.00000e+00 -791 1.45000e+00 1.00000e+00 0.00000e+00 -792 1.60000e+00 7.40192e-01 0.00000e+00 -793 1.70000e+00 4.80385e-01 0.00000e+00 -794 1.62500e+00 6.96891e-01 0.00000e+00 -795 1.75000e+00 2.59808e-01 0.00000e+00 -796 1.65000e+00 6.53590e-01 0.00000e+00 -797 1.77500e+00 4.33013e-02 0.00000e+00 -798 1.72500e+00 4.37083e-01 0.00000e+00 -799 1.77500e+00 1.29904e-01 0.00000e+00 -800 1.67500e+00 6.10289e-01 0.00000e+00 -801 1.75000e+00 3.46410e-01 0.00000e+00 -802 1.77500e+00 2.16506e-01 0.00000e+00 -803 1.70000e+00 5.66987e-01 0.00000e+00 -804 1.55000e+00 9.13397e-01 0.00000e+00 -805 1.57500e+00 8.70096e-01 0.00000e+00 -806 1.80000e+00 0.00000e+00 0.00000e+00 -807 1.52500e+00 9.56699e-01 0.00000e+00 -808 1.77500e+00 3.03109e-01 0.00000e+00 -809 1.60000e+00 8.26795e-01 0.00000e+00 -810 1.80000e+00 8.66025e-02 0.00000e+00 -811 1.72500e+00 5.23686e-01 0.00000e+00 -812 1.50000e+00 1.00000e+00 0.00000e+00 -813 1.62500e+00 7.83494e-01 0.00000e+00 -814 1.80000e+00 1.73205e-01 0.00000e+00 -815 1.65000e+00 7.40192e-01 0.00000e+00 -816 1.67500e+00 6.96891e-01 0.00000e+00 -817 1.75000e+00 4.80385e-01 0.00000e+00 -818 1.77500e+00 3.89711e-01 0.00000e+00 -819 1.80000e+00 2.59808e-01 0.00000e+00 -820 1.70000e+00 6.53590e-01 0.00000e+00 -821 1.82500e+00 4.33013e-02 0.00000e+00 -822 1.82500e+00 1.29904e-01 0.00000e+00 -823 1.80000e+00 3.46410e-01 0.00000e+00 -824 1.82500e+00 2.16506e-01 0.00000e+00 -825 1.60000e+00 9.13397e-01 0.00000e+00 -826 1.57500e+00 9.56699e-01 0.00000e+00 -827 1.62500e+00 8.70096e-01 0.00000e+00 -828 1.55000e+00 1.00000e+00 0.00000e+00 -829 1.65000e+00 8.26795e-01 0.00000e+00 -830 1.67500e+00 7.83494e-01 0.00000e+00 -831 1.82500e+00 3.03109e-01 0.00000e+00 -832 1.85000e+00 0.00000e+00 0.00000e+00 -833 1.80000e+00 4.33013e-01 0.00000e+00 -834 1.75000e+00 6.06218e-01 0.00000e+00 -835 1.85000e+00 8.66025e-02 0.00000e+00 -836 1.70000e+00 7.40192e-01 0.00000e+00 -837 1.85000e+00 1.73205e-01 0.00000e+00 -838 1.72500e+00 6.96891e-01 0.00000e+00 -839 1.77500e+00 5.62917e-01 0.00000e+00 -840 1.82500e+00 3.89711e-01 0.00000e+00 -841 1.85000e+00 2.59808e-01 0.00000e+00 -842 1.80000e+00 5.19615e-01 0.00000e+00 -843 1.87500e+00 4.33013e-02 0.00000e+00 -844 1.87500e+00 1.29904e-01 0.00000e+00 -845 1.85000e+00 3.46410e-01 0.00000e+00 -846 1.62500e+00 9.56699e-01 0.00000e+00 -847 1.65000e+00 9.13397e-01 0.00000e+00 -848 1.82500e+00 4.76314e-01 0.00000e+00 -849 1.60000e+00 1.00000e+00 0.00000e+00 -850 1.87500e+00 2.16506e-01 0.00000e+00 -851 1.67500e+00 8.70096e-01 0.00000e+00 -852 1.77500e+00 6.49519e-01 0.00000e+00 -853 1.80000e+00 6.06218e-01 0.00000e+00 -854 1.87500e+00 3.03109e-01 0.00000e+00 -855 1.85000e+00 4.33013e-01 0.00000e+00 -856 1.90000e+00 0.00000e+00 0.00000e+00 -857 1.90000e+00 8.66025e-02 0.00000e+00 -858 1.90000e+00 1.73205e-01 0.00000e+00 -859 1.82500e+00 5.62917e-01 0.00000e+00 -860 1.72500e+00 8.22724e-01 0.00000e+00 -861 1.87500e+00 3.89711e-01 0.00000e+00 -862 1.75000e+00 7.79423e-01 0.00000e+00 -863 1.90000e+00 2.59808e-01 0.00000e+00 -864 1.77500e+00 7.36122e-01 0.00000e+00 -865 1.85000e+00 5.19615e-01 0.00000e+00 -866 1.92500e+00 4.33013e-02 0.00000e+00 -867 1.80000e+00 6.92820e-01 0.00000e+00 -868 1.67500e+00 9.56699e-01 0.00000e+00 -869 1.92500e+00 1.29904e-01 0.00000e+00 -870 1.65000e+00 1.00000e+00 0.00000e+00 -871 1.70000e+00 9.13397e-01 0.00000e+00 -872 1.90000e+00 3.46410e-01 0.00000e+00 -873 1.87500e+00 4.76314e-01 0.00000e+00 -874 1.82500e+00 6.49519e-01 0.00000e+00 -875 1.92500e+00 2.16506e-01 0.00000e+00 -876 1.85000e+00 6.06218e-01 0.00000e+00 -877 1.90000e+00 4.33013e-01 0.00000e+00 -878 1.92500e+00 3.03109e-01 0.00000e+00 -879 1.95000e+00 0.00000e+00 0.00000e+00 -880 1.95000e+00 8.66025e-02 0.00000e+00 -881 1.75000e+00 8.66025e-01 0.00000e+00 -882 1.77500e+00 8.22724e-01 0.00000e+00 -883 1.87500e+00 5.62917e-01 0.00000e+00 -884 1.95000e+00 1.73205e-01 0.00000e+00 -885 1.80000e+00 7.79423e-01 0.00000e+00 -886 1.92500e+00 3.89711e-01 0.00000e+00 -887 1.95000e+00 2.59808e-01 0.00000e+00 -888 1.82500e+00 7.36122e-01 0.00000e+00 -889 1.90000e+00 5.19615e-01 0.00000e+00 -890 1.70000e+00 1.00000e+00 0.00000e+00 -891 1.72500e+00 9.56699e-01 0.00000e+00 -892 1.85000e+00 6.92820e-01 0.00000e+00 -893 1.97500e+00 4.33013e-02 0.00000e+00 -894 1.97500e+00 1.29904e-01 0.00000e+00 -895 1.95000e+00 3.46410e-01 0.00000e+00 -896 1.92500e+00 4.76314e-01 0.00000e+00 -897 1.87500e+00 6.49519e-01 0.00000e+00 -898 1.97500e+00 2.16506e-01 0.00000e+00 -899 1.77500e+00 9.09327e-01 0.00000e+00 -900 1.90000e+00 6.06218e-01 0.00000e+00 -901 1.80000e+00 8.66025e-01 0.00000e+00 -902 1.95000e+00 4.33013e-01 0.00000e+00 -903 1.97500e+00 3.03109e-01 0.00000e+00 -904 2.00000e+00 0.00000e+00 0.00000e+00 -905 1.82500e+00 8.22724e-01 0.00000e+00 -906 2.00000e+00 8.66025e-02 0.00000e+00 -907 1.92500e+00 5.62917e-01 0.00000e+00 -908 1.85000e+00 7.79423e-01 0.00000e+00 -909 2.00000e+00 1.73205e-01 0.00000e+00 -910 1.97500e+00 3.89711e-01 0.00000e+00 -911 1.87500e+00 7.36122e-01 0.00000e+00 -912 1.75000e+00 1.00000e+00 0.00000e+00 -913 1.77500e+00 9.56699e-01 0.00000e+00 -914 2.00000e+00 2.59808e-01 0.00000e+00 -915 1.95000e+00 5.19615e-01 0.00000e+00 -916 1.90000e+00 6.92820e-01 0.00000e+00 -917 2.02500e+00 4.33013e-02 0.00000e+00 -918 2.02500e+00 1.29904e-01 0.00000e+00 -919 2.00000e+00 3.46410e-01 0.00000e+00 -920 1.92500e+00 6.49519e-01 0.00000e+00 -921 1.97500e+00 4.76314e-01 0.00000e+00 -922 2.02500e+00 2.16506e-01 0.00000e+00 -923 1.82500e+00 9.09327e-01 0.00000e+00 -924 1.95000e+00 6.06218e-01 0.00000e+00 -925 1.85000e+00 8.66025e-01 0.00000e+00 -926 2.00000e+00 4.33013e-01 0.00000e+00 -927 1.87500e+00 8.22724e-01 0.00000e+00 -928 2.02500e+00 3.03109e-01 0.00000e+00 -929 2.05000e+00 0.00000e+00 0.00000e+00 -930 2.05000e+00 8.66025e-02 0.00000e+00 -931 1.90000e+00 7.79423e-01 0.00000e+00 -932 1.97500e+00 5.62917e-01 0.00000e+00 -933 2.05000e+00 1.73205e-01 0.00000e+00 -934 1.80000e+00 1.00000e+00 0.00000e+00 -935 1.82500e+00 9.56699e-01 0.00000e+00 -936 1.92500e+00 7.36122e-01 0.00000e+00 -937 2.02500e+00 3.89711e-01 0.00000e+00 -938 2.00000e+00 5.19615e-01 0.00000e+00 -939 2.05000e+00 2.59808e-01 0.00000e+00 -940 1.95000e+00 6.92820e-01 0.00000e+00 -941 2.07500e+00 4.33013e-02 0.00000e+00 -942 1.97500e+00 6.49519e-01 0.00000e+00 -943 2.05000e+00 3.46410e-01 0.00000e+00 -944 2.07500e+00 1.29904e-01 0.00000e+00 -945 2.02500e+00 4.76314e-01 0.00000e+00 -946 1.87500e+00 9.09327e-01 0.00000e+00 -947 2.07500e+00 2.16506e-01 0.00000e+00 -948 1.90000e+00 8.66025e-01 0.00000e+00 -949 2.00000e+00 6.06218e-01 0.00000e+00 -950 1.92500e+00 8.22724e-01 0.00000e+00 -951 2.05000e+00 4.33013e-01 0.00000e+00 -952 2.07500e+00 3.03109e-01 0.00000e+00 -953 1.95000e+00 7.79423e-01 0.00000e+00 -954 2.10000e+00 0.00000e+00 0.00000e+00 -955 2.02500e+00 5.62917e-01 0.00000e+00 -956 2.10000e+00 8.66025e-02 0.00000e+00 -957 1.85000e+00 1.00000e+00 0.00000e+00 -958 2.10000e+00 1.73205e-01 0.00000e+00 -959 1.97500e+00 7.36122e-01 0.00000e+00 -960 2.07500e+00 3.89711e-01 0.00000e+00 -961 2.05000e+00 5.19615e-01 0.00000e+00 -962 2.10000e+00 2.59808e-01 0.00000e+00 -963 2.00000e+00 6.92820e-01 0.00000e+00 -964 1.90000e+00 9.52628e-01 0.00000e+00 -965 2.12500e+00 4.33013e-02 0.00000e+00 -966 2.02500e+00 6.49519e-01 0.00000e+00 -967 2.10000e+00 3.46410e-01 0.00000e+00 -968 1.92500e+00 9.09327e-01 0.00000e+00 -969 2.07500e+00 4.76314e-01 0.00000e+00 -970 2.12500e+00 1.29904e-01 0.00000e+00 -971 1.95000e+00 8.66025e-01 0.00000e+00 -972 2.12500e+00 2.16506e-01 0.00000e+00 -973 2.05000e+00 6.06218e-01 0.00000e+00 -974 1.97500e+00 8.22724e-01 0.00000e+00 -975 2.10000e+00 4.33013e-01 0.00000e+00 -976 2.00000e+00 7.79423e-01 0.00000e+00 -977 2.12500e+00 3.03109e-01 0.00000e+00 -978 1.90000e+00 1.00000e+00 0.00000e+00 -979 2.07500e+00 5.62917e-01 0.00000e+00 -980 2.15000e+00 0.00000e+00 0.00000e+00 -981 2.15000e+00 8.66025e-02 0.00000e+00 -982 2.02500e+00 7.36122e-01 0.00000e+00 -983 2.15000e+00 1.73205e-01 0.00000e+00 -984 2.12500e+00 3.89711e-01 0.00000e+00 -985 2.10000e+00 5.19615e-01 0.00000e+00 -986 2.05000e+00 6.92820e-01 0.00000e+00 -987 2.15000e+00 2.59808e-01 0.00000e+00 -988 1.95000e+00 9.52628e-01 0.00000e+00 -989 1.97500e+00 9.09327e-01 0.00000e+00 -990 2.07500e+00 6.49519e-01 0.00000e+00 -991 2.17500e+00 4.33013e-02 0.00000e+00 -992 2.12500e+00 4.76314e-01 0.00000e+00 -993 2.15000e+00 3.46410e-01 0.00000e+00 -994 2.17500e+00 1.29904e-01 0.00000e+00 -995 2.00000e+00 8.66025e-01 0.00000e+00 -996 2.02500e+00 8.22724e-01 0.00000e+00 -997 2.10000e+00 6.06218e-01 0.00000e+00 -998 2.17500e+00 2.16506e-01 0.00000e+00 -999 1.95000e+00 1.00000e+00 0.00000e+00 -1000 2.05000e+00 7.79423e-01 0.00000e+00 -1001 2.15000e+00 4.33013e-01 0.00000e+00 -1002 2.17500e+00 3.03109e-01 0.00000e+00 -1003 2.12500e+00 5.62917e-01 0.00000e+00 -1004 2.20000e+00 0.00000e+00 0.00000e+00 -1005 2.07500e+00 7.36122e-01 0.00000e+00 -1006 2.20000e+00 8.66025e-02 0.00000e+00 -1007 2.20000e+00 1.73205e-01 0.00000e+00 -1008 2.17500e+00 3.89711e-01 0.00000e+00 -1009 2.10000e+00 6.92820e-01 0.00000e+00 -1010 2.15000e+00 5.19615e-01 0.00000e+00 -1011 2.00000e+00 9.52628e-01 0.00000e+00 -1012 2.20000e+00 2.59808e-01 0.00000e+00 -1013 2.12500e+00 6.49519e-01 0.00000e+00 -1014 2.03011e+00 9.09224e-01 0.00000e+00 -1015 2.05000e+00 8.66025e-01 0.00000e+00 -1016 2.22500e+00 4.33013e-02 0.00000e+00 -1017 2.17500e+00 4.76314e-01 0.00000e+00 -1018 2.20000e+00 3.46410e-01 0.00000e+00 -1019 2.22500e+00 1.29904e-01 0.00000e+00 -1020 2.15000e+00 6.06218e-01 0.00000e+00 -1021 2.07636e+00 8.24832e-01 0.00000e+00 -1022 2.22500e+00 2.16506e-01 0.00000e+00 -1023 2.00000e+00 1.00000e+00 0.00000e+00 -1024 2.10000e+00 7.79423e-01 0.00000e+00 -1025 2.20000e+00 4.33013e-01 0.00000e+00 -1026 2.22500e+00 3.03109e-01 0.00000e+00 -1027 2.17500e+00 5.62917e-01 0.00000e+00 -1028 2.12500e+00 7.36122e-01 0.00000e+00 -1029 2.25000e+00 0.00000e+00 0.00000e+00 -1030 2.25000e+00 8.66025e-02 0.00000e+00 -1031 2.25000e+00 1.73205e-01 0.00000e+00 -1032 2.15000e+00 6.92820e-01 0.00000e+00 -1033 2.22500e+00 3.89711e-01 0.00000e+00 -1034 2.20000e+00 5.19615e-01 0.00000e+00 -1035 2.25000e+00 2.59808e-01 0.00000e+00 -1036 2.17500e+00 6.49519e-01 0.00000e+00 -1037 2.10000e+00 8.66025e-01 0.00000e+00 -1038 2.22500e+00 4.76314e-01 0.00000e+00 -1039 2.27500e+00 4.33013e-02 0.00000e+00 -1040 2.06726e+00 9.53328e-01 0.00000e+00 -1041 2.25000e+00 3.46410e-01 0.00000e+00 -1042 2.08840e+00 9.08013e-01 0.00000e+00 -1043 2.27500e+00 1.29904e-01 0.00000e+00 -1044 2.05000e+00 1.00000e+00 0.00000e+00 -1045 2.20000e+00 6.06218e-01 0.00000e+00 -1046 2.27500e+00 2.16506e-01 0.00000e+00 -1047 2.13317e+00 8.35371e-01 0.00000e+00 -1048 2.25000e+00 4.33013e-01 0.00000e+00 -1049 2.15517e+00 7.83593e-01 0.00000e+00 -1050 2.22500e+00 5.62917e-01 0.00000e+00 -1051 2.27500e+00 3.03109e-01 0.00000e+00 -1052 2.17500e+00 7.36122e-01 0.00000e+00 -1053 2.30000e+00 0.00000e+00 0.00000e+00 -1054 2.30000e+00 8.66025e-02 0.00000e+00 -1055 2.20000e+00 6.92820e-01 0.00000e+00 -1056 2.30000e+00 1.73205e-01 0.00000e+00 -1057 2.27500e+00 3.89711e-01 0.00000e+00 -1058 2.25000e+00 5.19615e-01 0.00000e+00 -1059 2.30000e+00 2.59808e-01 0.00000e+00 -1060 2.22500e+00 6.49519e-01 0.00000e+00 -1061 2.14019e+00 9.00000e-01 0.00000e+00 -1062 2.27500e+00 4.76314e-01 0.00000e+00 -1063 2.30000e+00 3.46410e-01 0.00000e+00 -1064 2.10000e+00 1.00000e+00 0.00000e+00 -1065 2.32917e+00 4.44177e-02 0.00000e+00 -1066 2.25000e+00 6.06218e-01 0.00000e+00 -1067 2.32917e+00 1.33253e-01 0.00000e+00 -1068 2.18349e+00 8.25000e-01 0.00000e+00 -1069 2.32917e+00 2.13755e-01 0.00000e+00 -1070 2.30000e+00 4.33013e-01 0.00000e+00 -1071 2.14019e+00 9.50000e-01 0.00000e+00 -1072 2.27500e+00 5.62917e-01 0.00000e+00 -1073 2.32500e+00 3.03109e-01 0.00000e+00 -1074 2.23058e+00 7.35477e-01 0.00000e+00 -1075 2.35000e+00 0.00000e+00 0.00000e+00 -1076 2.35000e+00 8.66025e-02 0.00000e+00 -1077 2.18349e+00 8.75000e-01 0.00000e+00 -1078 2.21589e+00 7.90027e-01 0.00000e+00 -1079 2.25000e+00 6.92820e-01 0.00000e+00 -1080 2.30000e+00 5.19615e-01 0.00000e+00 -1081 2.35167e+00 1.74043e-01 0.00000e+00 -1082 2.32917e+00 3.91426e-01 0.00000e+00 -1083 2.35000e+00 2.59808e-01 0.00000e+00 -1084 2.27500e+00 6.49519e-01 0.00000e+00 -1085 2.15000e+00 1.00000e+00 0.00000e+00 -1086 2.35000e+00 3.46410e-01 0.00000e+00 -1087 2.18624e+00 9.29167e-01 0.00000e+00 -1088 2.30000e+00 6.06218e-01 0.00000e+00 -1089 2.22679e+00 8.50000e-01 0.00000e+00 -1090 2.33929e+00 4.75939e-01 0.00000e+00 -1091 2.27402e+00 7.26577e-01 0.00000e+00 -1092 2.35000e+00 4.33013e-01 0.00000e+00 -1093 2.32917e+00 5.60764e-01 0.00000e+00 -1094 2.27010e+00 7.75000e-01 0.00000e+00 -1095 2.40000e+00 0.00000e+00 0.00000e+00 -1096 2.40000e+00 5.00000e-02 0.00000e+00 -1097 2.22679e+00 9.00000e-01 0.00000e+00 -1098 2.30000e+00 6.92820e-01 0.00000e+00 -1099 2.40000e+00 1.00000e-01 0.00000e+00 -1100 2.40000e+00 1.50000e-01 0.00000e+00 -1101 2.40000e+00 2.00000e-01 0.00000e+00 -1102 2.35369e+00 5.21264e-01 0.00000e+00 -1103 2.40000e+00 2.50000e-01 0.00000e+00 -1104 2.32500e+00 6.49519e-01 0.00000e+00 -1105 2.27010e+00 8.25000e-01 0.00000e+00 -1106 2.20000e+00 1.00000e+00 0.00000e+00 -1107 2.40000e+00 3.00000e-01 0.00000e+00 -1108 2.22691e+00 9.53690e-01 0.00000e+00 -1109 2.40000e+00 3.50000e-01 0.00000e+00 -1110 2.35000e+00 6.06218e-01 0.00000e+00 -1111 2.27010e+00 8.75000e-01 0.00000e+00 -1112 2.40000e+00 4.00000e-01 0.00000e+00 -1113 2.32500e+00 7.36122e-01 0.00000e+00 -1114 2.40000e+00 4.50000e-01 0.00000e+00 -1115 2.44442e+00 7.08333e-02 0.00000e+00 -1116 2.44330e+00 1.25000e-01 0.00000e+00 -1117 2.31340e+00 8.00000e-01 0.00000e+00 -1118 2.44330e+00 1.75000e-01 0.00000e+00 -1119 2.35000e+00 6.92820e-01 0.00000e+00 -1120 2.45000e+00 0.00000e+00 0.00000e+00 -1121 2.40000e+00 5.00000e-01 0.00000e+00 -1122 2.44330e+00 2.25000e-01 0.00000e+00 -1123 2.27150e+00 9.39286e-01 0.00000e+00 -1124 2.44330e+00 2.75000e-01 0.00000e+00 -1125 2.25000e+00 1.00000e+00 0.00000e+00 -1126 2.40000e+00 5.50000e-01 0.00000e+00 -1127 2.31340e+00 8.50000e-01 0.00000e+00 -1128 2.45018e+00 3.25112e-01 0.00000e+00 -1129 2.40000e+00 6.00000e-01 0.00000e+00 -1130 2.44642e+00 3.74964e-01 0.00000e+00 -1131 2.35670e+00 7.75000e-01 0.00000e+00 -1132 2.44417e+00 4.27478e-01 0.00000e+00 -1133 2.31340e+00 9.00000e-01 0.00000e+00 -1134 2.40000e+00 6.50000e-01 0.00000e+00 -1135 2.48660e+00 5.00000e-02 0.00000e+00 -1136 2.48660e+00 1.00000e-01 0.00000e+00 -1137 2.44431e+00 4.77222e-01 0.00000e+00 -1138 2.48660e+00 1.50000e-01 0.00000e+00 -1139 2.48660e+00 2.00000e-01 0.00000e+00 -1140 2.35670e+00 8.25000e-01 0.00000e+00 -1141 2.44127e+00 5.26954e-01 0.00000e+00 -1142 2.48660e+00 2.50000e-01 0.00000e+00 -1143 2.50000e+00 0.00000e+00 0.00000e+00 -1144 2.40000e+00 7.00000e-01 0.00000e+00 -1145 2.31340e+00 9.50000e-01 0.00000e+00 -1146 2.48660e+00 3.00000e-01 0.00000e+00 -1147 2.30000e+00 1.00000e+00 0.00000e+00 -1148 2.44275e+00 5.76596e-01 0.00000e+00 -1149 2.35670e+00 8.75000e-01 0.00000e+00 -1150 2.40000e+00 7.50000e-01 0.00000e+00 -1151 2.43708e+00 6.25000e-01 0.00000e+00 -1152 2.49146e+00 3.53314e-01 0.00000e+00 -1153 2.48774e+00 4.03074e-01 0.00000e+00 -1154 2.48687e+00 4.53002e-01 0.00000e+00 -1155 2.43708e+00 6.75000e-01 0.00000e+00 -1156 2.52850e+00 6.07143e-02 0.00000e+00 -1157 2.40000e+00 8.00000e-01 0.00000e+00 -1158 2.35558e+00 9.29167e-01 0.00000e+00 -1159 2.52990e+00 1.25000e-01 0.00000e+00 -1160 2.48287e+00 5.01806e-01 0.00000e+00 -1161 2.52990e+00 1.75000e-01 0.00000e+00 -1162 2.52990e+00 2.25000e-01 0.00000e+00 -1163 2.43708e+00 7.25000e-01 0.00000e+00 -1164 2.52990e+00 2.75000e-01 0.00000e+00 -1165 2.48443e+00 5.51526e-01 0.00000e+00 -1166 2.40000e+00 8.50000e-01 0.00000e+00 -1167 2.55000e+00 0.00000e+00 0.00000e+00 -1168 2.48038e+00 6.00000e-01 0.00000e+00 -1169 2.35000e+00 1.00000e+00 0.00000e+00 -1170 2.53623e+00 3.24613e-01 0.00000e+00 -1171 2.44275e+00 7.73404e-01 0.00000e+00 -1172 2.40000e+00 9.00000e-01 0.00000e+00 -1173 2.52720e+00 4.31018e-01 0.00000e+00 -1174 2.48038e+00 6.50000e-01 0.00000e+00 -1175 2.43658e+00 8.22066e-01 0.00000e+00 -1176 2.54553e+00 3.77156e-01 0.00000e+00 -1177 2.52803e+00 4.80940e-01 0.00000e+00 -1178 2.57364e+00 4.71429e-02 0.00000e+00 -1179 2.57321e+00 1.00000e-01 0.00000e+00 -1180 2.48038e+00 7.00000e-01 0.00000e+00 -1181 2.57321e+00 1.50000e-01 0.00000e+00 -1182 2.52628e+00 5.26100e-01 0.00000e+00 -1183 2.57321e+00 2.00000e-01 0.00000e+00 -1184 2.40000e+00 9.50000e-01 0.00000e+00 -1185 2.52369e+00 5.75000e-01 0.00000e+00 -1186 2.48038e+00 7.50000e-01 0.00000e+00 -1187 2.58040e+00 2.46346e-01 0.00000e+00 -1188 2.44457e+00 8.70446e-01 0.00000e+00 -1189 2.52369e+00 6.25000e-01 0.00000e+00 -1190 2.60000e+00 0.00000e+00 0.00000e+00 -1191 2.40000e+00 1.00000e+00 0.00000e+00 -1192 2.58652e+00 2.93765e-01 0.00000e+00 -1193 2.57290e+00 4.10984e-01 0.00000e+00 -1194 2.48038e+00 8.00000e-01 0.00000e+00 -1195 2.57073e+00 4.55481e-01 0.00000e+00 -1196 2.52369e+00 6.75000e-01 0.00000e+00 -1197 2.59069e+00 3.42209e-01 0.00000e+00 -1198 2.44434e+00 9.27871e-01 0.00000e+00 -1199 2.61651e+00 7.50000e-02 0.00000e+00 -1200 2.61651e+00 1.25000e-01 0.00000e+00 -1201 2.47796e+00 8.49705e-01 0.00000e+00 -1202 2.57042e+00 5.05193e-01 0.00000e+00 -1203 2.52369e+00 7.25000e-01 0.00000e+00 -1204 2.62110e+00 1.72951e-01 0.00000e+00 -1205 2.56822e+00 5.52845e-01 0.00000e+00 -1206 2.60530e+00 3.83303e-01 0.00000e+00 -1207 2.56699e+00 6.00000e-01 0.00000e+00 -1208 2.52369e+00 7.75000e-01 0.00000e+00 -1209 2.63175e+00 2.17711e-01 0.00000e+00 -1210 2.48411e+00 8.96858e-01 0.00000e+00 -1211 2.61044e+00 4.31722e-01 0.00000e+00 -1212 2.45000e+00 1.00000e+00 0.00000e+00 -1213 2.56699e+00 6.50000e-01 0.00000e+00 -1214 2.65000e+00 0.00000e+00 0.00000e+00 -1215 2.65317e+00 4.04781e-02 0.00000e+00 -1216 2.52369e+00 8.25000e-01 0.00000e+00 -1217 2.63743e+00 3.14054e-01 0.00000e+00 -1218 2.64445e+00 2.60365e-01 0.00000e+00 -1219 2.61412e+00 4.81181e-01 0.00000e+00 -1220 2.56699e+00 7.00000e-01 0.00000e+00 -1221 2.65981e+00 1.00000e-01 0.00000e+00 -1222 2.48738e+00 9.49922e-01 0.00000e+00 -1223 2.65981e+00 1.50000e-01 0.00000e+00 -1224 2.61258e+00 5.31016e-01 0.00000e+00 -1225 2.52397e+00 8.67679e-01 0.00000e+00 -1226 2.64781e+00 3.57610e-01 0.00000e+00 -1227 2.60952e+00 5.80782e-01 0.00000e+00 -1228 2.56699e+00 7.50000e-01 0.00000e+00 -1229 2.64767e+00 4.07286e-01 0.00000e+00 -1230 2.61029e+00 6.25000e-01 0.00000e+00 -1231 2.56699e+00 8.00000e-01 0.00000e+00 -1232 2.52962e+00 9.17208e-01 0.00000e+00 -1233 2.50000e+00 1.00000e+00 0.00000e+00 -1234 2.65448e+00 4.54537e-01 0.00000e+00 -1235 2.69270e+00 6.78684e-02 0.00000e+00 -1236 2.68737e+00 1.87706e-01 0.00000e+00 -1237 2.68485e+00 2.38360e-01 0.00000e+00 -1238 2.61029e+00 6.75000e-01 0.00000e+00 -1239 2.65137e+00 5.02796e-01 0.00000e+00 -1240 2.52026e+00 9.65808e-01 0.00000e+00 -1241 2.70000e+00 0.00000e+00 0.00000e+00 -1242 2.68632e+00 2.87440e-01 0.00000e+00 -1243 2.68211e+00 3.36703e-01 0.00000e+00 -1244 2.56699e+00 8.50000e-01 0.00000e+00 -1245 2.64887e+00 5.50700e-01 0.00000e+00 -1246 2.61029e+00 7.25000e-01 0.00000e+00 -1247 2.69087e+00 3.83220e-01 0.00000e+00 -1248 2.71662e+00 1.20894e-01 0.00000e+00 -1249 2.56699e+00 9.00000e-01 0.00000e+00 -1250 2.65359e+00 6.00000e-01 0.00000e+00 -1251 2.68815e+00 4.32590e-01 0.00000e+00 -1252 2.61029e+00 7.75000e-01 0.00000e+00 -1253 2.65359e+00 6.50000e-01 0.00000e+00 -1254 2.56642e+00 9.47935e-01 0.00000e+00 -1255 2.61029e+00 8.25000e-01 0.00000e+00 -1256 2.73789e+00 5.37572e-02 0.00000e+00 -1257 2.73018e+00 2.13506e-01 0.00000e+00 -1258 2.69614e+00 4.81450e-01 0.00000e+00 -1259 2.55000e+00 1.00000e+00 0.00000e+00 -1260 2.72906e+00 2.63433e-01 0.00000e+00 -1261 2.73715e+00 1.71328e-01 0.00000e+00 -1262 2.72499e+00 3.12285e-01 0.00000e+00 -1263 2.65359e+00 7.00000e-01 0.00000e+00 -1264 2.69336e+00 5.29009e-01 0.00000e+00 -1265 2.72239e+00 3.61564e-01 0.00000e+00 -1266 2.75000e+00 0.00000e+00 0.00000e+00 -1267 2.61029e+00 8.75000e-01 0.00000e+00 -1268 2.69433e+00 5.71219e-01 0.00000e+00 -1269 2.65359e+00 7.50000e-01 0.00000e+00 -1270 2.73275e+00 4.10281e-01 0.00000e+00 -1271 2.69689e+00 6.25000e-01 0.00000e+00 -1272 2.60848e+00 9.28822e-01 0.00000e+00 -1273 2.73382e+00 4.51716e-01 0.00000e+00 -1274 2.65359e+00 8.00000e-01 0.00000e+00 -1275 2.73332e+00 4.99715e-01 0.00000e+00 -1276 2.77529e+00 1.42725e-01 0.00000e+00 -1277 2.75977e+00 3.32233e-01 0.00000e+00 -1278 2.69689e+00 6.75000e-01 0.00000e+00 -1279 2.77629e+00 1.91807e-01 0.00000e+00 -1280 2.78255e+00 9.18416e-02 0.00000e+00 -1281 2.77401e+00 2.41663e-01 0.00000e+00 -1282 2.77018e+00 2.91455e-01 0.00000e+00 -1283 2.60000e+00 1.00000e+00 0.00000e+00 -1284 2.78549e+00 4.19390e-02 0.00000e+00 -1285 2.65359e+00 8.50000e-01 0.00000e+00 -1286 2.73714e+00 5.49117e-01 0.00000e+00 -1287 2.69689e+00 7.25000e-01 0.00000e+00 -1288 2.76954e+00 3.77592e-01 0.00000e+00 -1289 2.80000e+00 0.00000e+00 0.00000e+00 -1290 2.73560e+00 5.98643e-01 0.00000e+00 -1291 2.65359e+00 9.00000e-01 0.00000e+00 -1292 2.69689e+00 7.75000e-01 0.00000e+00 -1293 2.77673e+00 4.26285e-01 0.00000e+00 -1294 2.74019e+00 6.50000e-01 0.00000e+00 -1295 2.77687e+00 4.76163e-01 0.00000e+00 -1296 2.65359e+00 9.50000e-01 0.00000e+00 -1297 2.69689e+00 8.25000e-01 0.00000e+00 -1298 2.80553e+00 3.29514e-01 0.00000e+00 -1299 2.77570e+00 5.26026e-01 0.00000e+00 -1300 2.82080e+00 1.69073e-01 0.00000e+00 -1301 2.81815e+00 2.18980e-01 0.00000e+00 -1302 2.82614e+00 5.68331e-02 0.00000e+00 -1303 2.82434e+00 1.19213e-01 0.00000e+00 -1304 2.81443e+00 2.68473e-01 0.00000e+00 -1305 2.74019e+00 7.00000e-01 0.00000e+00 -1306 2.65000e+00 1.00000e+00 0.00000e+00 -1307 2.69689e+00 8.75000e-01 0.00000e+00 -1308 2.77965e+00 5.75222e-01 0.00000e+00 -1309 2.74019e+00 7.50000e-01 0.00000e+00 -1310 2.81597e+00 3.95620e-01 0.00000e+00 -1311 2.77795e+00 6.25165e-01 0.00000e+00 -1312 2.85000e+00 0.00000e+00 0.00000e+00 -1313 2.69689e+00 9.25000e-01 0.00000e+00 -1314 2.74019e+00 8.00000e-01 0.00000e+00 -1315 2.82301e+00 4.45074e-01 0.00000e+00 -1316 2.81662e+00 4.97374e-01 0.00000e+00 -1317 2.78287e+00 6.73761e-01 0.00000e+00 -1318 2.74019e+00 8.50000e-01 0.00000e+00 -1319 2.86572e+00 1.47252e-01 0.00000e+00 -1320 2.86309e+00 1.97123e-01 0.00000e+00 -1321 2.85947e+00 2.46969e-01 0.00000e+00 -1322 2.86852e+00 9.73338e-02 0.00000e+00 -1323 2.85633e+00 2.95698e-01 0.00000e+00 -1324 2.87208e+00 4.75042e-02 0.00000e+00 -1325 2.82083e+00 5.47156e-01 0.00000e+00 -1326 2.85688e+00 3.57352e-01 0.00000e+00 -1327 2.70000e+00 1.00000e+00 0.00000e+00 -1328 2.78724e+00 7.23551e-01 0.00000e+00 -1329 2.74019e+00 9.00000e-01 0.00000e+00 -1330 2.82463e+00 5.96972e-01 0.00000e+00 -1331 2.78349e+00 7.75000e-01 0.00000e+00 -1332 2.86236e+00 4.14248e-01 0.00000e+00 -1333 2.82349e+00 6.45107e-01 0.00000e+00 -1334 2.90000e+00 0.00000e+00 0.00000e+00 -1335 2.74019e+00 9.50000e-01 0.00000e+00 -1336 2.78349e+00 8.25000e-01 0.00000e+00 -1337 2.86939e+00 4.63748e-01 0.00000e+00 -1338 2.86188e+00 5.18615e-01 0.00000e+00 -1339 2.91070e+00 7.09107e-02 0.00000e+00 -1340 2.82814e+00 6.94819e-01 0.00000e+00 -1341 2.90394e+00 2.24269e-01 0.00000e+00 -1342 2.90749e+00 1.74633e-01 0.00000e+00 -1343 2.91034e+00 1.24730e-01 0.00000e+00 -1344 2.90111e+00 2.74117e-01 0.00000e+00 -1345 2.89752e+00 3.23915e-01 0.00000e+00 -1346 2.78349e+00 8.75000e-01 0.00000e+00 -1347 2.86591e+00 5.68778e-01 0.00000e+00 -1348 2.82679e+00 7.50000e-01 0.00000e+00 -1349 2.75000e+00 1.00000e+00 0.00000e+00 -1350 2.90355e+00 3.85115e-01 0.00000e+00 -1351 2.86735e+00 6.22059e-01 0.00000e+00 -1352 2.78624e+00 9.29167e-01 0.00000e+00 -1353 2.82679e+00 8.00000e-01 0.00000e+00 -1354 2.86556e+00 6.71913e-01 0.00000e+00 -1355 2.91340e+00 4.50000e-01 0.00000e+00 -1356 2.95000e+00 0.00000e+00 0.00000e+00 -1357 2.82679e+00 8.50000e-01 0.00000e+00 -1358 2.94890e+00 2.02535e-01 0.00000e+00 -1359 2.91340e+00 5.00000e-01 0.00000e+00 -1360 2.95239e+00 1.52671e-01 0.00000e+00 -1361 2.94576e+00 2.51645e-01 0.00000e+00 -1362 2.95513e+00 1.02883e-01 0.00000e+00 -1363 2.94251e+00 3.02131e-01 0.00000e+00 -1364 2.95810e+00 5.30134e-02 0.00000e+00 -1365 2.87010e+00 7.25000e-01 0.00000e+00 -1366 2.91340e+00 5.50000e-01 0.00000e+00 -1367 2.82679e+00 9.00000e-01 0.00000e+00 -1368 2.91148e+00 5.98572e-01 0.00000e+00 -1369 2.95005e+00 3.64360e-01 0.00000e+00 -1370 2.87010e+00 7.75000e-01 0.00000e+00 -1371 2.80000e+00 1.00000e+00 0.00000e+00 -1372 2.90973e+00 6.48535e-01 0.00000e+00 -1373 2.82691e+00 9.53690e-01 0.00000e+00 -1374 2.95395e+00 4.20746e-01 0.00000e+00 -1375 2.87010e+00 8.25000e-01 0.00000e+00 -1376 2.95670e+00 4.75000e-01 0.00000e+00 -1377 2.91340e+00 7.00000e-01 0.00000e+00 -1378 3.00000e+00 0.00000e+00 0.00000e+00 -1379 3.00000e+00 5.00000e-02 0.00000e+00 -1380 2.87010e+00 8.75000e-01 0.00000e+00 -1381 3.00000e+00 1.00000e-01 0.00000e+00 -1382 2.95670e+00 5.25000e-01 0.00000e+00 -1383 3.00000e+00 1.50000e-01 0.00000e+00 -1384 3.00000e+00 2.00000e-01 0.00000e+00 -1385 2.91340e+00 7.50000e-01 0.00000e+00 -1386 3.00000e+00 2.50000e-01 0.00000e+00 -1387 2.95670e+00 5.75000e-01 0.00000e+00 -1388 3.00000e+00 3.00000e-01 0.00000e+00 -1389 3.00000e+00 3.50000e-01 0.00000e+00 -1390 2.85000e+00 1.00000e+00 0.00000e+00 -1391 2.87150e+00 9.39286e-01 0.00000e+00 -1392 2.91340e+00 8.00000e-01 0.00000e+00 -1393 2.95670e+00 6.25000e-01 0.00000e+00 -1394 3.00000e+00 4.00000e-01 0.00000e+00 -1395 2.95670e+00 6.75000e-01 0.00000e+00 -1396 3.00000e+00 4.50000e-01 0.00000e+00 -1397 2.91340e+00 8.50000e-01 0.00000e+00 -1398 3.00000e+00 5.00000e-01 0.00000e+00 -1399 2.95670e+00 7.25000e-01 0.00000e+00 -1400 2.91340e+00 9.00000e-01 0.00000e+00 -1401 3.05000e+00 0.00000e+00 0.00000e+00 -1402 3.00000e+00 5.50000e-01 0.00000e+00 -1403 3.05313e+00 7.33723e-02 0.00000e+00 -1404 2.95670e+00 7.75000e-01 0.00000e+00 -1405 3.00000e+00 6.00000e-01 0.00000e+00 -1406 3.05197e+00 2.26365e-01 0.00000e+00 -1407 3.05810e+00 1.27477e-01 0.00000e+00 -1408 3.05603e+00 1.76765e-01 0.00000e+00 -1409 3.05050e+00 2.76110e-01 0.00000e+00 -1410 2.91340e+00 9.50000e-01 0.00000e+00 -1411 2.90000e+00 1.00000e+00 0.00000e+00 -1412 3.00000e+00 6.50000e-01 0.00000e+00 -1413 2.95670e+00 8.25000e-01 0.00000e+00 -1414 3.05440e+00 3.26168e-01 0.00000e+00 -1415 3.04890e+00 3.75094e-01 0.00000e+00 -1416 3.00000e+00 7.00000e-01 0.00000e+00 -1417 3.05242e+00 4.24316e-01 0.00000e+00 -1418 2.95670e+00 8.75000e-01 0.00000e+00 -1419 3.04752e+00 4.73530e-01 0.00000e+00 -1420 3.04330e+00 5.25000e-01 0.00000e+00 -1421 3.00000e+00 7.50000e-01 0.00000e+00 -1422 3.04330e+00 5.75000e-01 0.00000e+00 -1423 2.95558e+00 9.29167e-01 0.00000e+00 -1424 3.10000e+00 0.00000e+00 0.00000e+00 -1425 3.09843e+00 1.55885e-01 0.00000e+00 -1426 3.09648e+00 2.05744e-01 0.00000e+00 -1427 3.09392e+00 2.51796e-01 0.00000e+00 -1428 3.00000e+00 8.00000e-01 0.00000e+00 -1429 3.09021e+00 3.01578e-01 0.00000e+00 -1430 3.04330e+00 6.25000e-01 0.00000e+00 -1431 3.10750e+00 5.64759e-02 0.00000e+00 -1432 3.10944e+00 1.01576e-01 0.00000e+00 -1433 3.09235e+00 3.57538e-01 0.00000e+00 -1434 2.95000e+00 1.00000e+00 0.00000e+00 -1435 3.04330e+00 6.75000e-01 0.00000e+00 -1436 3.09223e+00 3.98702e-01 0.00000e+00 -1437 3.00000e+00 8.50000e-01 0.00000e+00 -1438 3.09145e+00 4.54700e-01 0.00000e+00 -1439 3.04330e+00 7.25000e-01 0.00000e+00 -1440 3.09014e+00 4.95160e-01 0.00000e+00 -1441 3.00000e+00 9.00000e-01 0.00000e+00 -1442 3.08660e+00 5.50000e-01 0.00000e+00 -1443 3.04330e+00 7.75000e-01 0.00000e+00 -1444 3.08660e+00 6.00000e-01 0.00000e+00 -1445 3.14045e+00 1.82804e-01 0.00000e+00 -1446 3.00000e+00 9.50000e-01 0.00000e+00 -1447 3.13506e+00 2.79649e-01 0.00000e+00 -1448 3.13909e+00 2.31113e-01 0.00000e+00 -1449 3.15000e+00 0.00000e+00 0.00000e+00 -1450 3.13335e+00 3.29397e-01 0.00000e+00 -1451 3.04330e+00 8.25000e-01 0.00000e+00 -1452 3.08660e+00 6.50000e-01 0.00000e+00 -1453 3.13762e+00 3.78102e-01 0.00000e+00 -1454 3.13308e+00 4.27278e-01 0.00000e+00 -1455 3.00000e+00 1.00000e+00 0.00000e+00 -1456 3.16183e+00 1.30441e-01 0.00000e+00 -1457 3.08660e+00 7.00000e-01 0.00000e+00 -1458 3.04330e+00 8.75000e-01 0.00000e+00 -1459 3.16687e+00 7.33233e-02 0.00000e+00 -1460 3.13625e+00 4.76562e-01 0.00000e+00 -1461 3.12990e+00 5.25000e-01 0.00000e+00 -1462 3.08660e+00 7.50000e-01 0.00000e+00 -1463 3.12990e+00 5.75000e-01 0.00000e+00 -1464 3.04442e+00 9.29167e-01 0.00000e+00 -1465 3.17807e+00 2.13136e-01 0.00000e+00 -1466 3.17625e+00 2.62593e-01 0.00000e+00 -1467 3.08660e+00 8.00000e-01 0.00000e+00 -1468 3.18436e+00 1.71890e-01 0.00000e+00 -1469 3.17687e+00 3.06661e-01 0.00000e+00 -1470 3.12990e+00 6.25000e-01 0.00000e+00 -1471 3.17584e+00 3.53577e-01 0.00000e+00 -1472 3.20000e+00 0.00000e+00 0.00000e+00 -1473 3.08660e+00 8.50000e-01 0.00000e+00 -1474 3.12990e+00 6.75000e-01 0.00000e+00 -1475 3.17665e+00 4.08372e-01 0.00000e+00 -1476 3.17610e+00 4.47396e-01 0.00000e+00 -1477 3.05000e+00 1.00000e+00 0.00000e+00 -1478 3.21010e+00 4.35163e-02 0.00000e+00 -1479 3.17321e+00 5.00000e-01 0.00000e+00 -1480 3.12990e+00 7.25000e-01 0.00000e+00 -1481 3.21259e+00 9.33824e-02 0.00000e+00 -1482 3.08660e+00 9.00000e-01 0.00000e+00 -1483 3.17321e+00 5.50000e-01 0.00000e+00 -1484 3.21857e+00 1.41855e-01 0.00000e+00 -1485 3.13013e+00 7.80443e-01 0.00000e+00 -1486 3.21901e+00 2.40940e-01 0.00000e+00 -1487 3.22287e+00 1.91216e-01 0.00000e+00 -1488 3.12156e+00 8.27620e-01 0.00000e+00 -1489 3.17321e+00 6.00000e-01 0.00000e+00 -1490 3.08660e+00 9.50000e-01 0.00000e+00 -1491 3.22007e+00 2.82025e-01 0.00000e+00 -1492 3.22027e+00 3.30929e-01 0.00000e+00 -1493 3.17321e+00 6.50000e-01 0.00000e+00 -1494 3.21791e+00 3.80363e-01 0.00000e+00 -1495 3.12990e+00 8.75000e-01 0.00000e+00 -1496 3.25000e+00 0.00000e+00 0.00000e+00 -1497 3.22173e+00 4.29705e-01 0.00000e+00 -1498 3.21651e+00 4.75000e-01 0.00000e+00 -1499 3.17449e+00 7.05719e-01 0.00000e+00 -1500 3.25441e+00 6.65130e-02 0.00000e+00 -1501 3.10000e+00 1.00000e+00 0.00000e+00 -1502 3.25577e+00 1.16207e-01 0.00000e+00 -1503 3.21651e+00 5.25000e-01 0.00000e+00 -1504 3.17321e+00 7.50000e-01 0.00000e+00 -1505 3.25941e+00 2.12289e-01 0.00000e+00 -1506 3.26277e+00 1.64241e-01 0.00000e+00 -1507 3.21651e+00 5.75000e-01 0.00000e+00 -1508 3.13462e+00 9.25548e-01 0.00000e+00 -1509 3.16644e+00 8.25864e-01 0.00000e+00 -1510 3.26469e+00 2.60082e-01 0.00000e+00 -1511 3.26044e+00 3.09628e-01 0.00000e+00 -1512 3.21651e+00 6.25000e-01 0.00000e+00 -1513 3.26091e+00 3.59186e-01 0.00000e+00 -1514 3.26151e+00 4.00268e-01 0.00000e+00 -1515 3.21851e+00 6.77351e-01 0.00000e+00 -1516 3.25981e+00 4.50000e-01 0.00000e+00 -1517 3.17366e+00 8.82629e-01 0.00000e+00 -1518 3.29623e+00 3.96655e-02 0.00000e+00 -1519 3.25981e+00 5.00000e-01 0.00000e+00 -1520 3.29751e+00 8.93446e-02 0.00000e+00 -1521 3.30000e+00 0.00000e+00 0.00000e+00 -1522 3.29864e+00 1.38971e-01 0.00000e+00 -1523 3.15000e+00 1.00000e+00 0.00000e+00 -1524 3.25981e+00 5.50000e-01 0.00000e+00 -1525 3.30281e+00 1.88423e-01 0.00000e+00 -1526 3.30012e+00 2.37878e-01 0.00000e+00 -1527 3.22224e+00 7.56965e-01 0.00000e+00 -1528 3.29919e+00 2.85575e-01 0.00000e+00 -1529 3.25981e+00 6.00000e-01 0.00000e+00 -1530 3.18098e+00 9.45661e-01 0.00000e+00 -1531 3.21926e+00 8.06864e-01 0.00000e+00 -1532 3.30281e+00 3.35334e-01 0.00000e+00 -1533 3.26106e+00 6.51137e-01 0.00000e+00 -1534 3.30544e+00 3.77671e-01 0.00000e+00 -1535 3.21736e+00 8.58489e-01 0.00000e+00 -1536 3.30328e+00 4.27311e-01 0.00000e+00 -1537 3.30311e+00 4.75000e-01 0.00000e+00 -1538 3.34016e+00 6.33925e-02 0.00000e+00 -1539 3.26336e+00 7.17157e-01 0.00000e+00 -1540 3.21655e+00 9.08178e-01 0.00000e+00 -1541 3.34243e+00 1.11384e-01 0.00000e+00 -1542 3.30311e+00 5.25000e-01 0.00000e+00 -1543 3.34298e+00 1.61260e-01 0.00000e+00 -1544 3.34092e+00 2.09708e-01 0.00000e+00 -1545 3.35000e+00 0.00000e+00 0.00000e+00 -1546 3.20000e+00 1.00000e+00 0.00000e+00 -1547 3.30311e+00 5.75000e-01 0.00000e+00 -1548 3.34553e+00 2.57796e-01 0.00000e+00 -1549 3.26407e+00 7.79008e-01 0.00000e+00 -1550 3.34393e+00 3.07661e-01 0.00000e+00 -1551 3.22139e+00 9.57529e-01 0.00000e+00 -1552 3.30390e+00 6.26111e-01 0.00000e+00 -1553 3.26103e+00 8.34251e-01 0.00000e+00 -1554 3.34799e+00 3.55712e-01 0.00000e+00 -1555 3.34675e+00 4.05278e-01 0.00000e+00 -1556 3.30481e+00 6.74519e-01 0.00000e+00 -1557 3.34641e+00 4.50000e-01 0.00000e+00 -1558 3.26027e+00 8.84050e-01 0.00000e+00 -1559 3.37928e+00 3.89980e-02 0.00000e+00 -1560 3.34641e+00 5.00000e-01 0.00000e+00 -1561 3.38562e+00 8.62458e-02 0.00000e+00 -1562 3.38569e+00 1.36215e-01 0.00000e+00 -1563 3.38431e+00 1.85709e-01 0.00000e+00 -1564 3.38194e+00 2.35235e-01 0.00000e+00 -1565 3.25941e+00 9.33805e-01 0.00000e+00 -1566 3.34641e+00 5.50000e-01 0.00000e+00 -1567 3.31336e+00 7.45545e-01 0.00000e+00 -1568 3.38771e+00 2.84438e-01 0.00000e+00 -1569 3.34641e+00 6.00000e-01 0.00000e+00 -1570 3.40000e+00 0.00000e+00 0.00000e+00 -1571 3.25000e+00 1.00000e+00 0.00000e+00 -1572 3.38439e+00 3.33888e-01 0.00000e+00 -1573 3.30516e+00 8.12476e-01 0.00000e+00 -1574 3.34794e+00 6.49546e-01 0.00000e+00 -1575 3.38951e+00 3.82809e-01 0.00000e+00 -1576 3.30344e+00 8.59215e-01 0.00000e+00 -1577 3.39056e+00 4.25610e-01 0.00000e+00 -1578 3.34829e+00 6.98886e-01 0.00000e+00 -1579 3.42064e+00 4.53515e-02 0.00000e+00 -1580 3.38971e+00 4.75000e-01 0.00000e+00 -1581 3.30252e+00 9.08951e-01 0.00000e+00 -1582 3.42278e+00 2.06584e-01 0.00000e+00 -1583 3.38971e+00 5.25000e-01 0.00000e+00 -1584 3.42829e+00 1.62169e-01 0.00000e+00 -1585 3.42677e+00 2.56310e-01 0.00000e+00 -1586 3.38971e+00 5.75000e-01 0.00000e+00 -1587 3.42472e+00 3.04402e-01 0.00000e+00 -1588 3.30259e+00 9.58891e-01 0.00000e+00 -1589 3.43825e+00 9.92605e-02 0.00000e+00 -1590 3.34912e+00 7.88893e-01 0.00000e+00 -1591 3.35873e+00 7.47873e-01 0.00000e+00 -1592 3.38927e+00 6.22174e-01 0.00000e+00 -1593 3.30000e+00 1.00000e+00 0.00000e+00 -1594 3.43015e+00 3.53938e-01 0.00000e+00 -1595 3.45000e+00 0.00000e+00 0.00000e+00 -1596 3.34777e+00 8.38418e-01 0.00000e+00 -1597 3.38962e+00 6.71935e-01 0.00000e+00 -1598 3.43504e+00 4.03103e-01 0.00000e+00 -1599 3.34562e+00 8.84102e-01 0.00000e+00 -1600 3.43178e+00 4.52845e-01 0.00000e+00 -1601 3.39260e+00 7.21682e-01 0.00000e+00 -1602 3.43301e+00 5.00000e-01 0.00000e+00 -1603 3.46815e+00 1.36988e-01 0.00000e+00 -1604 3.34570e+00 9.34038e-01 0.00000e+00 -1605 3.47010e+00 1.75000e-01 0.00000e+00 -1606 3.47500e+00 4.33013e-02 0.00000e+00 -1607 3.43301e+00 5.50000e-01 0.00000e+00 -1608 3.47010e+00 2.25000e-01 0.00000e+00 -1609 3.39401e+00 7.71465e-01 0.00000e+00 -1610 3.47010e+00 2.75000e-01 0.00000e+00 -1611 3.43301e+00 6.00000e-01 0.00000e+00 -1612 3.47010e+00 3.25000e-01 0.00000e+00 -1613 3.39055e+00 8.13426e-01 0.00000e+00 -1614 3.43211e+00 6.46041e-01 0.00000e+00 -1615 3.47428e+00 3.76167e-01 0.00000e+00 -1616 3.35000e+00 1.00000e+00 0.00000e+00 -1617 3.39101e+00 8.63310e-01 0.00000e+00 -1618 3.47372e+00 4.26100e-01 0.00000e+00 -1619 3.50000e+00 0.00000e+00 0.00000e+00 -1620 3.50000e+00 8.66025e-02 0.00000e+00 -1621 3.43152e+00 6.95778e-01 0.00000e+00 -1622 3.38646e+00 9.12809e-01 0.00000e+00 -1623 3.47631e+00 4.75000e-01 0.00000e+00 -1624 3.47631e+00 5.25000e-01 0.00000e+00 -1625 3.43606e+00 7.44777e-01 0.00000e+00 -1626 3.51340e+00 1.50000e-01 0.00000e+00 -1627 3.51340e+00 2.00000e-01 0.00000e+00 -1628 3.38608e+00 9.61829e-01 0.00000e+00 -1629 3.51340e+00 2.50000e-01 0.00000e+00 -1630 3.47631e+00 5.75000e-01 0.00000e+00 -1631 3.52500e+00 4.33013e-02 0.00000e+00 -1632 3.51340e+00 3.00000e-01 0.00000e+00 -1633 3.43629e+00 7.94335e-01 0.00000e+00 -1634 3.51340e+00 3.50000e-01 0.00000e+00 -1635 3.47631e+00 6.25000e-01 0.00000e+00 -1636 3.43087e+00 8.42253e-01 0.00000e+00 -1637 3.47444e+00 6.70635e-01 0.00000e+00 -1638 3.51713e+00 4.01806e-01 0.00000e+00 -1639 3.40000e+00 1.00000e+00 0.00000e+00 -1640 3.51557e+00 4.51526e-01 0.00000e+00 -1641 3.47073e+00 7.20413e-01 0.00000e+00 -1642 3.43116e+00 8.91069e-01 0.00000e+00 -1643 3.55000e+00 0.00000e+00 0.00000e+00 -1644 3.51962e+00 5.00000e-01 0.00000e+00 -1645 3.55634e+00 8.09808e-02 0.00000e+00 -1646 3.42817e+00 9.49753e-01 0.00000e+00 -1647 3.55670e+00 1.25000e-01 0.00000e+00 -1648 3.55670e+00 1.75000e-01 0.00000e+00 -1649 3.47829e+00 7.68025e-01 0.00000e+00 -1650 3.51962e+00 5.50000e-01 0.00000e+00 -1651 3.55670e+00 2.25000e-01 0.00000e+00 -1652 3.47207e+00 8.17185e-01 0.00000e+00 -1653 3.55670e+00 2.75000e-01 0.00000e+00 -1654 3.51962e+00 6.00000e-01 0.00000e+00 -1655 3.55670e+00 3.25000e-01 0.00000e+00 -1656 3.55670e+00 3.75000e-01 0.00000e+00 -1657 3.51962e+00 6.50000e-01 0.00000e+00 -1658 3.47398e+00 8.66710e-01 0.00000e+00 -1659 3.55873e+00 4.26954e-01 0.00000e+00 -1660 3.51557e+00 6.98474e-01 0.00000e+00 -1661 3.55725e+00 4.76596e-01 0.00000e+00 -1662 3.45000e+00 1.00000e+00 0.00000e+00 -1663 3.47398e+00 9.16526e-01 0.00000e+00 -1664 3.51572e+00 7.48390e-01 0.00000e+00 -1665 3.60000e+00 0.00000e+00 0.00000e+00 -1666 3.60000e+00 5.00000e-02 0.00000e+00 -1667 3.56292e+00 5.25000e-01 0.00000e+00 -1668 3.60000e+00 1.00000e-01 0.00000e+00 -1669 3.60000e+00 1.50000e-01 0.00000e+00 -1670 3.47259e+00 9.63176e-01 0.00000e+00 -1671 3.60000e+00 2.00000e-01 0.00000e+00 -1672 3.51712e+00 7.96554e-01 0.00000e+00 -1673 3.60000e+00 2.50000e-01 0.00000e+00 -1674 3.56292e+00 5.75000e-01 0.00000e+00 -1675 3.60000e+00 3.00000e-01 0.00000e+00 -1676 3.51600e+00 8.46261e-01 0.00000e+00 -1677 3.60000e+00 3.50000e-01 0.00000e+00 -1678 3.56292e+00 6.25000e-01 0.00000e+00 -1679 3.55725e+00 6.73404e-01 0.00000e+00 -1680 3.60000e+00 4.00000e-01 0.00000e+00 -1681 3.51393e+00 8.95421e-01 0.00000e+00 -1682 3.60000e+00 4.50000e-01 0.00000e+00 -1683 3.55873e+00 7.23046e-01 0.00000e+00 -1684 3.60000e+00 5.00000e-01 0.00000e+00 -1685 3.51080e+00 9.49600e-01 0.00000e+00 -1686 3.55569e+00 7.72778e-01 0.00000e+00 -1687 3.50000e+00 1.00000e+00 0.00000e+00 -1688 3.60000e+00 5.50000e-01 0.00000e+00 -1689 3.64442e+00 7.08333e-02 0.00000e+00 -1690 3.64330e+00 1.25000e-01 0.00000e+00 -1691 3.64330e+00 1.75000e-01 0.00000e+00 -1692 3.60000e+00 6.00000e-01 0.00000e+00 -1693 3.65000e+00 0.00000e+00 0.00000e+00 -1694 3.64330e+00 2.25000e-01 0.00000e+00 -1695 3.55913e+00 8.21526e-01 0.00000e+00 -1696 3.60000e+00 6.50000e-01 0.00000e+00 -1697 3.65000e+00 3.07180e-01 0.00000e+00 -1698 3.55823e+00 8.72656e-01 0.00000e+00 -1699 3.60000e+00 7.00000e-01 0.00000e+00 -1700 3.65000e+00 3.93782e-01 0.00000e+00 -1701 3.55549e+00 9.27946e-01 0.00000e+00 -1702 3.60000e+00 7.50000e-01 0.00000e+00 -1703 3.64631e+00 4.78736e-01 0.00000e+00 -1704 3.67500e+00 2.63878e-01 0.00000e+00 -1705 3.68660e+00 5.00000e-02 0.00000e+00 -1706 3.60000e+00 8.00000e-01 0.00000e+00 -1707 3.68660e+00 1.00000e-01 0.00000e+00 -1708 3.55000e+00 1.00000e+00 0.00000e+00 -1709 3.68660e+00 1.50000e-01 0.00000e+00 -1710 3.67500e+00 3.50481e-01 0.00000e+00 -1711 3.68660e+00 2.00000e-01 0.00000e+00 -1712 3.65000e+00 5.66987e-01 0.00000e+00 -1713 3.67083e+00 4.39236e-01 0.00000e+00 -1714 3.66071e+00 5.24061e-01 0.00000e+00 -1715 3.60000e+00 8.50000e-01 0.00000e+00 -1716 3.70000e+00 0.00000e+00 0.00000e+00 -1717 3.65000e+00 6.53590e-01 0.00000e+00 -1718 3.60000e+00 9.00000e-01 0.00000e+00 -1719 3.70000e+00 3.07180e-01 0.00000e+00 -1720 3.70000e+00 3.93782e-01 0.00000e+00 -1721 3.67083e+00 6.08574e-01 0.00000e+00 -1722 3.60000e+00 9.50000e-01 0.00000e+00 -1723 3.65000e+00 7.40192e-01 0.00000e+00 -1724 3.70000e+00 4.80385e-01 0.00000e+00 -1725 3.72990e+00 1.25000e-01 0.00000e+00 -1726 3.72990e+00 1.75000e-01 0.00000e+00 -1727 3.72598e+00 2.73423e-01 0.00000e+00 -1728 3.60000e+00 1.00000e+00 0.00000e+00 -1729 3.72990e+00 2.25000e-01 0.00000e+00 -1730 3.73772e+00 7.03953e-02 0.00000e+00 -1731 3.67500e+00 6.96891e-01 0.00000e+00 -1732 3.64833e+00 8.25957e-01 0.00000e+00 -1733 3.72500e+00 3.50481e-01 0.00000e+00 -1734 3.70000e+00 5.66987e-01 0.00000e+00 -1735 3.75000e+00 0.00000e+00 0.00000e+00 -1736 3.72500e+00 4.37083e-01 0.00000e+00 -1737 3.67083e+00 7.86245e-01 0.00000e+00 -1738 3.70000e+00 6.53590e-01 0.00000e+00 -1739 3.72500e+00 5.23686e-01 0.00000e+00 -1740 3.65000e+00 9.13397e-01 0.00000e+00 -1741 3.75000e+00 3.07180e-01 0.00000e+00 -1742 3.75000e+00 3.93782e-01 0.00000e+00 -1743 3.67083e+00 8.66747e-01 0.00000e+00 -1744 3.70000e+00 7.40192e-01 0.00000e+00 -1745 3.72500e+00 6.10289e-01 0.00000e+00 -1746 3.77624e+00 9.56232e-02 0.00000e+00 -1747 3.76962e+00 2.64577e-01 0.00000e+00 -1748 3.75000e+00 4.80385e-01 0.00000e+00 -1749 3.65000e+00 1.00000e+00 0.00000e+00 -1750 3.72500e+00 6.96891e-01 0.00000e+00 -1751 3.77500e+00 3.50481e-01 0.00000e+00 -1752 3.70000e+00 8.26795e-01 0.00000e+00 -1753 3.78855e+00 1.44675e-01 0.00000e+00 -1754 3.75000e+00 5.66987e-01 0.00000e+00 -1755 3.78686e+00 2.10801e-01 0.00000e+00 -1756 3.67083e+00 9.55582e-01 0.00000e+00 -1757 3.80000e+00 0.00000e+00 0.00000e+00 -1758 3.77500e+00 4.37083e-01 0.00000e+00 -1759 3.80000e+00 4.73721e-02 0.00000e+00 -1760 3.72500e+00 7.83494e-01 0.00000e+00 -1761 3.75000e+00 6.53590e-01 0.00000e+00 -1762 3.70000e+00 9.13397e-01 0.00000e+00 -1763 3.77500e+00 5.23686e-01 0.00000e+00 -1764 3.80000e+00 3.07180e-01 0.00000e+00 -1765 3.80000e+00 3.93782e-01 0.00000e+00 -1766 3.75000e+00 7.40192e-01 0.00000e+00 -1767 3.77500e+00 6.10289e-01 0.00000e+00 -1768 3.72500e+00 8.70096e-01 0.00000e+00 -1769 3.82500e+00 9.06733e-02 0.00000e+00 -1770 3.82500e+00 1.77276e-01 0.00000e+00 -1771 3.80000e+00 4.80385e-01 0.00000e+00 -1772 3.70000e+00 1.00000e+00 0.00000e+00 -1773 3.82500e+00 2.63878e-01 0.00000e+00 -1774 3.77500e+00 6.96891e-01 0.00000e+00 -1775 3.75000e+00 8.26795e-01 0.00000e+00 -1776 3.82500e+00 3.50481e-01 0.00000e+00 -1777 3.80000e+00 5.66987e-01 0.00000e+00 -1778 3.72500e+00 9.56699e-01 0.00000e+00 -1779 3.82500e+00 4.37083e-01 0.00000e+00 -1780 3.85000e+00 0.00000e+00 0.00000e+00 -1781 3.85000e+00 4.73721e-02 0.00000e+00 -1782 3.84809e+00 1.35758e-01 0.00000e+00 -1783 3.84781e+00 2.18948e-01 0.00000e+00 -1784 3.77500e+00 7.83494e-01 0.00000e+00 -1785 3.80000e+00 6.53590e-01 0.00000e+00 -1786 3.75000e+00 9.13397e-01 0.00000e+00 -1787 3.82500e+00 5.23686e-01 0.00000e+00 -1788 3.85000e+00 3.07180e-01 0.00000e+00 -1789 3.85000e+00 3.93782e-01 0.00000e+00 -1790 3.80000e+00 7.40192e-01 0.00000e+00 -1791 3.82500e+00 6.10289e-01 0.00000e+00 -1792 3.77500e+00 8.70096e-01 0.00000e+00 -1793 3.87500e+00 9.06733e-02 0.00000e+00 -1794 3.87500e+00 1.77276e-01 0.00000e+00 -1795 3.85000e+00 4.80385e-01 0.00000e+00 -1796 3.75000e+00 1.00000e+00 0.00000e+00 -1797 3.87500e+00 2.63878e-01 0.00000e+00 -1798 3.82500e+00 6.96891e-01 0.00000e+00 -1799 3.80000e+00 8.26795e-01 0.00000e+00 -1800 3.87500e+00 3.50481e-01 0.00000e+00 -1801 3.85000e+00 5.66987e-01 0.00000e+00 -1802 3.77500e+00 9.56699e-01 0.00000e+00 -1803 3.87500e+00 4.37083e-01 0.00000e+00 -1804 3.90000e+00 0.00000e+00 0.00000e+00 -1805 3.90000e+00 4.73721e-02 0.00000e+00 -1806 3.90000e+00 1.33975e-01 0.00000e+00 -1807 3.82500e+00 7.83494e-01 0.00000e+00 -1808 3.85000e+00 6.53590e-01 0.00000e+00 -1809 3.90000e+00 2.20577e-01 0.00000e+00 -1810 3.80000e+00 9.13397e-01 0.00000e+00 -1811 3.87500e+00 5.23686e-01 0.00000e+00 -1812 3.90000e+00 3.07180e-01 0.00000e+00 -1813 3.90000e+00 3.93782e-01 0.00000e+00 -1814 3.85000e+00 7.40192e-01 0.00000e+00 -1815 3.82500e+00 8.70096e-01 0.00000e+00 -1816 3.87500e+00 6.10289e-01 0.00000e+00 -1817 3.92500e+00 9.06733e-02 0.00000e+00 -1818 3.92500e+00 1.77276e-01 0.00000e+00 -1819 3.80000e+00 1.00000e+00 0.00000e+00 -1820 3.90000e+00 4.80385e-01 0.00000e+00 -1821 3.92500e+00 2.63878e-01 0.00000e+00 -1822 3.87500e+00 6.96891e-01 0.00000e+00 -1823 3.85000e+00 8.26795e-01 0.00000e+00 -1824 3.92500e+00 3.50481e-01 0.00000e+00 -1825 3.90000e+00 5.66987e-01 0.00000e+00 -1826 3.82500e+00 9.56699e-01 0.00000e+00 -1827 3.92500e+00 4.37083e-01 0.00000e+00 -1828 3.95000e+00 0.00000e+00 0.00000e+00 -1829 3.95000e+00 4.73721e-02 0.00000e+00 -1830 3.95000e+00 1.33975e-01 0.00000e+00 -1831 3.87500e+00 7.83494e-01 0.00000e+00 -1832 3.90000e+00 6.53590e-01 0.00000e+00 -1833 3.95000e+00 2.20577e-01 0.00000e+00 -1834 3.85000e+00 9.13397e-01 0.00000e+00 -1835 3.92500e+00 5.23686e-01 0.00000e+00 -1836 3.95000e+00 3.07180e-01 0.00000e+00 -1837 3.95000e+00 3.93782e-01 0.00000e+00 -1838 3.90000e+00 7.40192e-01 0.00000e+00 -1839 3.87500e+00 8.70096e-01 0.00000e+00 -1840 3.92500e+00 6.10289e-01 0.00000e+00 -1841 3.97500e+00 9.06733e-02 0.00000e+00 -1842 3.85000e+00 1.00000e+00 0.00000e+00 -1843 3.97500e+00 1.77276e-01 0.00000e+00 -1844 3.95000e+00 4.80385e-01 0.00000e+00 -1845 3.97500e+00 2.63878e-01 0.00000e+00 -1846 3.92500e+00 6.96891e-01 0.00000e+00 -1847 3.90000e+00 8.26795e-01 0.00000e+00 -1848 3.97500e+00 3.50481e-01 0.00000e+00 -1849 3.95000e+00 5.66987e-01 0.00000e+00 -1850 3.87500e+00 9.56699e-01 0.00000e+00 -1851 3.97500e+00 4.37083e-01 0.00000e+00 -1852 4.00000e+00 0.00000e+00 0.00000e+00 -1853 4.00000e+00 4.73721e-02 0.00000e+00 -1854 4.00000e+00 1.33975e-01 0.00000e+00 -1855 3.92500e+00 7.83494e-01 0.00000e+00 -1856 3.95000e+00 6.53590e-01 0.00000e+00 -1857 3.90000e+00 9.13397e-01 0.00000e+00 -1858 4.00000e+00 2.20577e-01 0.00000e+00 -1859 3.97500e+00 5.23686e-01 0.00000e+00 -1860 4.00000e+00 3.07180e-01 0.00000e+00 -1861 3.95000e+00 7.40192e-01 0.00000e+00 -1862 4.00000e+00 3.93782e-01 0.00000e+00 -1863 3.92500e+00 8.70096e-01 0.00000e+00 -1864 3.97500e+00 6.10289e-01 0.00000e+00 -1865 4.02500e+00 9.06733e-02 0.00000e+00 -1866 3.90000e+00 1.00000e+00 0.00000e+00 -1867 4.00000e+00 4.80385e-01 0.00000e+00 -1868 4.02500e+00 1.77276e-01 0.00000e+00 -1869 4.02500e+00 2.63878e-01 0.00000e+00 -1870 3.95000e+00 8.26795e-01 0.00000e+00 -1871 3.97500e+00 6.96891e-01 0.00000e+00 -1872 3.92500e+00 9.56699e-01 0.00000e+00 -1873 4.00000e+00 5.66987e-01 0.00000e+00 -1874 4.02500e+00 3.50481e-01 0.00000e+00 -1875 4.02500e+00 4.37083e-01 0.00000e+00 -1876 4.05000e+00 0.00000e+00 0.00000e+00 -1877 4.05000e+00 4.73721e-02 0.00000e+00 -1878 3.97500e+00 7.83494e-01 0.00000e+00 -1879 4.05000e+00 1.33975e-01 0.00000e+00 -1880 4.00000e+00 6.53590e-01 0.00000e+00 -1881 3.95000e+00 9.13397e-01 0.00000e+00 -1882 4.05000e+00 2.20577e-01 0.00000e+00 -1883 4.02500e+00 5.23686e-01 0.00000e+00 -1884 4.05000e+00 3.07180e-01 0.00000e+00 -1885 4.00000e+00 7.40192e-01 0.00000e+00 -1886 4.05000e+00 3.93782e-01 0.00000e+00 -1887 3.97500e+00 8.70096e-01 0.00000e+00 -1888 4.02500e+00 6.10289e-01 0.00000e+00 -1889 3.95000e+00 1.00000e+00 0.00000e+00 -1890 4.07500e+00 9.06733e-02 0.00000e+00 -1891 4.05000e+00 4.80385e-01 0.00000e+00 -1892 4.07500e+00 1.77276e-01 0.00000e+00 -1893 4.07500e+00 2.63878e-01 0.00000e+00 -1894 4.00000e+00 8.26795e-01 0.00000e+00 -1895 4.02500e+00 6.96891e-01 0.00000e+00 -1896 3.97500e+00 9.56699e-01 0.00000e+00 -1897 4.05000e+00 5.66987e-01 0.00000e+00 -1898 4.07500e+00 3.50481e-01 0.00000e+00 -1899 4.07500e+00 4.37083e-01 0.00000e+00 -1900 4.10000e+00 0.00000e+00 0.00000e+00 -1901 4.10000e+00 4.73721e-02 0.00000e+00 -1902 4.02500e+00 7.83494e-01 0.00000e+00 -1903 4.10000e+00 1.33975e-01 0.00000e+00 -1904 4.05000e+00 6.53590e-01 0.00000e+00 -1905 4.00000e+00 9.13397e-01 0.00000e+00 -1906 4.10000e+00 2.20577e-01 0.00000e+00 -1907 4.07500e+00 5.23686e-01 0.00000e+00 -1908 4.10000e+00 3.07180e-01 0.00000e+00 -1909 4.05000e+00 7.40192e-01 0.00000e+00 -1910 4.02500e+00 8.70096e-01 0.00000e+00 -1911 4.10000e+00 3.93782e-01 0.00000e+00 -1912 4.07500e+00 6.10289e-01 0.00000e+00 -1913 4.00000e+00 1.00000e+00 0.00000e+00 -1914 4.12500e+00 9.06733e-02 0.00000e+00 -1915 4.10000e+00 4.80385e-01 0.00000e+00 -1916 4.12500e+00 1.77276e-01 0.00000e+00 -1917 4.12500e+00 2.63878e-01 0.00000e+00 -1918 4.05000e+00 8.26795e-01 0.00000e+00 -1919 4.07500e+00 6.96891e-01 0.00000e+00 -1920 4.02500e+00 9.56699e-01 0.00000e+00 -1921 4.10000e+00 5.66987e-01 0.00000e+00 -1922 4.12500e+00 3.50481e-01 0.00000e+00 -1923 4.12500e+00 4.37083e-01 0.00000e+00 -1924 4.07500e+00 7.83494e-01 0.00000e+00 -1925 4.15000e+00 0.00000e+00 0.00000e+00 -1926 4.15000e+00 4.73721e-02 0.00000e+00 -1927 4.05000e+00 9.13397e-01 0.00000e+00 -1928 4.10000e+00 6.53590e-01 0.00000e+00 -1929 4.15000e+00 1.33975e-01 0.00000e+00 -1930 4.15000e+00 2.20577e-01 0.00000e+00 -1931 4.12500e+00 5.23686e-01 0.00000e+00 -1932 4.15000e+00 3.07180e-01 0.00000e+00 -1933 4.10000e+00 7.40192e-01 0.00000e+00 -1934 4.07500e+00 8.70096e-01 0.00000e+00 -1935 4.15000e+00 3.93782e-01 0.00000e+00 -1936 4.12500e+00 6.10289e-01 0.00000e+00 -1937 4.05000e+00 1.00000e+00 0.00000e+00 -1938 4.17500e+00 9.06733e-02 0.00000e+00 -1939 4.15000e+00 4.80385e-01 0.00000e+00 -1940 4.17500e+00 1.77276e-01 0.00000e+00 -1941 4.10000e+00 8.26795e-01 0.00000e+00 -1942 4.17500e+00 2.63878e-01 0.00000e+00 -1943 4.12500e+00 6.96891e-01 0.00000e+00 -1944 4.07500e+00 9.56699e-01 0.00000e+00 -1945 4.15000e+00 5.66987e-01 0.00000e+00 -1946 4.17500e+00 3.50481e-01 0.00000e+00 -1947 4.17500e+00 4.37083e-01 0.00000e+00 -1948 4.12500e+00 7.83494e-01 0.00000e+00 -1949 4.20000e+00 0.00000e+00 0.00000e+00 -1950 4.20000e+00 4.73721e-02 0.00000e+00 -1951 4.10000e+00 9.13397e-01 0.00000e+00 -1952 4.15000e+00 6.53590e-01 0.00000e+00 -1953 4.20000e+00 1.33975e-01 0.00000e+00 -1954 4.20000e+00 2.20577e-01 0.00000e+00 -1955 4.17500e+00 5.23686e-01 0.00000e+00 -1956 4.20000e+00 3.07180e-01 0.00000e+00 -1957 4.15000e+00 7.40192e-01 0.00000e+00 -1958 4.12500e+00 8.70096e-01 0.00000e+00 -1959 4.20000e+00 3.93782e-01 0.00000e+00 -1960 4.17500e+00 6.10289e-01 0.00000e+00 -1961 4.10000e+00 1.00000e+00 0.00000e+00 -1962 4.22500e+00 9.06733e-02 0.00000e+00 -1963 4.20000e+00 4.80385e-01 0.00000e+00 -1964 4.22500e+00 1.77276e-01 0.00000e+00 -1965 4.15000e+00 8.26795e-01 0.00000e+00 -1966 4.17500e+00 6.96891e-01 0.00000e+00 -1967 4.22500e+00 2.63878e-01 0.00000e+00 -1968 4.12500e+00 9.56699e-01 0.00000e+00 -1969 4.20000e+00 5.66987e-01 0.00000e+00 -1970 4.22500e+00 3.50481e-01 0.00000e+00 -1971 4.22500e+00 4.37083e-01 0.00000e+00 -1972 4.17500e+00 7.83494e-01 0.00000e+00 -1973 4.15000e+00 9.13397e-01 0.00000e+00 -1974 4.25000e+00 0.00000e+00 0.00000e+00 -1975 4.25000e+00 4.73721e-02 0.00000e+00 -1976 4.20000e+00 6.53590e-01 0.00000e+00 -1977 4.25000e+00 1.33975e-01 0.00000e+00 -1978 4.25000e+00 2.20577e-01 0.00000e+00 -1979 4.22500e+00 5.23686e-01 0.00000e+00 -1980 4.25000e+00 3.07180e-01 0.00000e+00 -1981 4.17500e+00 8.70096e-01 0.00000e+00 -1982 4.20000e+00 7.40192e-01 0.00000e+00 -1983 4.25000e+00 3.93782e-01 0.00000e+00 -1984 4.15000e+00 1.00000e+00 0.00000e+00 -1985 4.22500e+00 6.10289e-01 0.00000e+00 -1986 4.27500e+00 9.06733e-02 0.00000e+00 -1987 4.25000e+00 4.80385e-01 0.00000e+00 -1988 4.27500e+00 1.77276e-01 0.00000e+00 -1989 4.20000e+00 8.26795e-01 0.00000e+00 -1990 4.22500e+00 6.96891e-01 0.00000e+00 -1991 4.27500e+00 2.63878e-01 0.00000e+00 -1992 4.17500e+00 9.56699e-01 0.00000e+00 -1993 4.25000e+00 5.66987e-01 0.00000e+00 -1994 4.27500e+00 3.50481e-01 0.00000e+00 -1995 4.22500e+00 7.83494e-01 0.00000e+00 -1996 4.27500e+00 4.37083e-01 0.00000e+00 -1997 4.20000e+00 9.13397e-01 0.00000e+00 -1998 4.25000e+00 6.53590e-01 0.00000e+00 -1999 4.30000e+00 0.00000e+00 0.00000e+00 -2000 4.30000e+00 4.73721e-02 0.00000e+00 -2001 4.30000e+00 1.33975e-01 0.00000e+00 -2002 4.30000e+00 2.20577e-01 0.00000e+00 -2003 4.27500e+00 5.23686e-01 0.00000e+00 -2004 4.30000e+00 3.07180e-01 0.00000e+00 -2005 4.22500e+00 8.70096e-01 0.00000e+00 -2006 4.25000e+00 7.40192e-01 0.00000e+00 -2007 4.20000e+00 1.00000e+00 0.00000e+00 -2008 4.30000e+00 3.93782e-01 0.00000e+00 -2009 4.27500e+00 6.10289e-01 0.00000e+00 -2010 4.32500e+00 9.06733e-02 0.00000e+00 -2011 4.30000e+00 4.80385e-01 0.00000e+00 -2012 4.32500e+00 1.77276e-01 0.00000e+00 -2013 4.25000e+00 8.26795e-01 0.00000e+00 -2014 4.27500e+00 6.96891e-01 0.00000e+00 -2015 4.22500e+00 9.56699e-01 0.00000e+00 -2016 4.32500e+00 2.63878e-01 0.00000e+00 -2017 4.30000e+00 5.66987e-01 0.00000e+00 -2018 4.32500e+00 3.50481e-01 0.00000e+00 -2019 4.27500e+00 7.83494e-01 0.00000e+00 -2020 4.32500e+00 4.37083e-01 0.00000e+00 -2021 4.25000e+00 9.13397e-01 0.00000e+00 -2022 4.30000e+00 6.53590e-01 0.00000e+00 -2023 4.35000e+00 0.00000e+00 0.00000e+00 -2024 4.35000e+00 4.73721e-02 0.00000e+00 -2025 4.35000e+00 1.33975e-01 0.00000e+00 -2026 4.35000e+00 2.20577e-01 0.00000e+00 -2027 4.32500e+00 5.23686e-01 0.00000e+00 -2028 4.35000e+00 3.07180e-01 0.00000e+00 -2029 4.27500e+00 8.70096e-01 0.00000e+00 -2030 4.30000e+00 7.40192e-01 0.00000e+00 -2031 4.25000e+00 1.00000e+00 0.00000e+00 -2032 4.35000e+00 3.93782e-01 0.00000e+00 -2033 4.32500e+00 6.10289e-01 0.00000e+00 -2034 4.37500e+00 9.06733e-02 0.00000e+00 -2035 4.35000e+00 4.80385e-01 0.00000e+00 -2036 4.37500e+00 1.77276e-01 0.00000e+00 -2037 4.30000e+00 8.26795e-01 0.00000e+00 -2038 4.27500e+00 9.56699e-01 0.00000e+00 -2039 4.32500e+00 6.96891e-01 0.00000e+00 -2040 4.37500e+00 2.63878e-01 0.00000e+00 -2041 4.35000e+00 5.66987e-01 0.00000e+00 -2042 4.37500e+00 3.50481e-01 0.00000e+00 -2043 4.32500e+00 7.83494e-01 0.00000e+00 -2044 4.30000e+00 9.13397e-01 0.00000e+00 -2045 4.37500e+00 4.37083e-01 0.00000e+00 -2046 4.35000e+00 6.53590e-01 0.00000e+00 -2047 4.40000e+00 0.00000e+00 0.00000e+00 -2048 4.40000e+00 4.73721e-02 0.00000e+00 -2049 4.40000e+00 1.33975e-01 0.00000e+00 -2050 4.40000e+00 2.20577e-01 0.00000e+00 -2051 4.37500e+00 5.23686e-01 0.00000e+00 -2052 4.40000e+00 3.07180e-01 0.00000e+00 -2053 4.32500e+00 8.70096e-01 0.00000e+00 -2054 4.35000e+00 7.40192e-01 0.00000e+00 -2055 4.30000e+00 1.00000e+00 0.00000e+00 -2056 4.37500e+00 6.10289e-01 0.00000e+00 -2057 4.40000e+00 3.93782e-01 0.00000e+00 -2058 4.42500e+00 9.06733e-02 0.00000e+00 -2059 4.40000e+00 4.80385e-01 0.00000e+00 -2060 4.35000e+00 8.26795e-01 0.00000e+00 -2061 4.42500e+00 1.77276e-01 0.00000e+00 -2062 4.32500e+00 9.56699e-01 0.00000e+00 -2063 4.37500e+00 6.96891e-01 0.00000e+00 -2064 4.42500e+00 2.63878e-01 0.00000e+00 -2065 4.40000e+00 5.66987e-01 0.00000e+00 -2066 4.42500e+00 3.50481e-01 0.00000e+00 -2067 4.37500e+00 7.83494e-01 0.00000e+00 -2068 4.35000e+00 9.13397e-01 0.00000e+00 -2069 4.42500e+00 4.37083e-01 0.00000e+00 -2070 4.40000e+00 6.53590e-01 0.00000e+00 -2071 4.45000e+00 0.00000e+00 0.00000e+00 -2072 4.45000e+00 4.73721e-02 0.00000e+00 -2073 4.45000e+00 1.33975e-01 0.00000e+00 -2074 4.45000e+00 2.20577e-01 0.00000e+00 -2075 4.42500e+00 5.23686e-01 0.00000e+00 -2076 4.45000e+00 3.07180e-01 0.00000e+00 -2077 4.37500e+00 8.70096e-01 0.00000e+00 -2078 4.40000e+00 7.40192e-01 0.00000e+00 -2079 4.35000e+00 1.00000e+00 0.00000e+00 -2080 4.42500e+00 6.10289e-01 0.00000e+00 -2081 4.45000e+00 3.93782e-01 0.00000e+00 -2082 4.45000e+00 4.80385e-01 0.00000e+00 -2083 4.47500e+00 9.06733e-02 0.00000e+00 -2084 4.40000e+00 8.26795e-01 0.00000e+00 -2085 4.37500e+00 9.56699e-01 0.00000e+00 -2086 4.47500e+00 1.77276e-01 0.00000e+00 -2087 4.42500e+00 6.96891e-01 0.00000e+00 -2088 4.47500e+00 2.63878e-01 0.00000e+00 -2089 4.45000e+00 5.66987e-01 0.00000e+00 -2090 4.47500e+00 3.50481e-01 0.00000e+00 -2091 4.40000e+00 9.13397e-01 0.00000e+00 -2092 4.42500e+00 7.83494e-01 0.00000e+00 -2093 4.47500e+00 4.37083e-01 0.00000e+00 -2094 4.45000e+00 6.53590e-01 0.00000e+00 -2095 4.50000e+00 0.00000e+00 0.00000e+00 -2096 4.50000e+00 4.73721e-02 0.00000e+00 -2097 4.50000e+00 1.33975e-01 0.00000e+00 -2098 4.50000e+00 2.20577e-01 0.00000e+00 -2099 4.47500e+00 5.23686e-01 0.00000e+00 -2100 4.42500e+00 8.70096e-01 0.00000e+00 -2101 4.50000e+00 3.07180e-01 0.00000e+00 -2102 4.45000e+00 7.40192e-01 0.00000e+00 -2103 4.40000e+00 1.00000e+00 0.00000e+00 -2104 4.47500e+00 6.10289e-01 0.00000e+00 -2105 4.50000e+00 3.93782e-01 0.00000e+00 -2106 4.50000e+00 4.80385e-01 0.00000e+00 -2107 4.52500e+00 9.06733e-02 0.00000e+00 -2108 4.45000e+00 8.26795e-01 0.00000e+00 -2109 4.42500e+00 9.56699e-01 0.00000e+00 -2110 4.52500e+00 1.77276e-01 0.00000e+00 -2111 4.47500e+00 6.96891e-01 0.00000e+00 -2112 4.52500e+00 2.63878e-01 0.00000e+00 -2113 4.50000e+00 5.66987e-01 0.00000e+00 -2114 4.52500e+00 3.50481e-01 0.00000e+00 -2115 4.45000e+00 9.13397e-01 0.00000e+00 -2116 4.47500e+00 7.83494e-01 0.00000e+00 -2117 4.52500e+00 4.37083e-01 0.00000e+00 -2118 4.50000e+00 6.53590e-01 0.00000e+00 -2119 4.55000e+00 0.00000e+00 0.00000e+00 -2120 4.55000e+00 4.73721e-02 0.00000e+00 -2121 4.55000e+00 1.33975e-01 0.00000e+00 -2122 4.52500e+00 5.23686e-01 0.00000e+00 -2123 4.55000e+00 2.20577e-01 0.00000e+00 -2124 4.47500e+00 8.70096e-01 0.00000e+00 -2125 4.55000e+00 3.07180e-01 0.00000e+00 -2126 4.50000e+00 7.40192e-01 0.00000e+00 -2127 4.45000e+00 1.00000e+00 0.00000e+00 -2128 4.52500e+00 6.10289e-01 0.00000e+00 -2129 4.55000e+00 3.93782e-01 0.00000e+00 -2130 4.55000e+00 4.80385e-01 0.00000e+00 -2131 4.50000e+00 8.26795e-01 0.00000e+00 -2132 4.57500e+00 9.06733e-02 0.00000e+00 -2133 4.47500e+00 9.56699e-01 0.00000e+00 -2134 4.52500e+00 6.96891e-01 0.00000e+00 -2135 4.57500e+00 1.77276e-01 0.00000e+00 -2136 4.57500e+00 2.63878e-01 0.00000e+00 -2137 4.55000e+00 5.66987e-01 0.00000e+00 -2138 4.57500e+00 3.50481e-01 0.00000e+00 -2139 4.50000e+00 9.13397e-01 0.00000e+00 -2140 4.52500e+00 7.83494e-01 0.00000e+00 -2141 4.57500e+00 4.37083e-01 0.00000e+00 -2142 4.55000e+00 6.53590e-01 0.00000e+00 -2143 4.60000e+00 0.00000e+00 0.00000e+00 -2144 4.60000e+00 4.73721e-02 0.00000e+00 -2145 4.60000e+00 1.33975e-01 0.00000e+00 -2146 4.57500e+00 5.23686e-01 0.00000e+00 -2147 4.60000e+00 2.20577e-01 0.00000e+00 -2148 4.52500e+00 8.70096e-01 0.00000e+00 -2149 4.50000e+00 1.00000e+00 0.00000e+00 -2150 4.55000e+00 7.40192e-01 0.00000e+00 -2151 4.60000e+00 3.07180e-01 0.00000e+00 -2152 4.57500e+00 6.10289e-01 0.00000e+00 -2153 4.60000e+00 3.93782e-01 0.00000e+00 -2154 4.55000e+00 8.26795e-01 0.00000e+00 -2155 4.60000e+00 4.80385e-01 0.00000e+00 -2156 4.52500e+00 9.56699e-01 0.00000e+00 -2157 4.62500e+00 9.06733e-02 0.00000e+00 -2158 4.57500e+00 6.96891e-01 0.00000e+00 -2159 4.62500e+00 1.77276e-01 0.00000e+00 -2160 4.62500e+00 2.63878e-01 0.00000e+00 -2161 4.60000e+00 5.66987e-01 0.00000e+00 -2162 4.62500e+00 3.50481e-01 0.00000e+00 -2163 4.55000e+00 9.13397e-01 0.00000e+00 -2164 4.57500e+00 7.83494e-01 0.00000e+00 -2165 4.62500e+00 4.37083e-01 0.00000e+00 -2166 4.60000e+00 6.53590e-01 0.00000e+00 -2167 4.65000e+00 0.00000e+00 0.00000e+00 -2168 4.65000e+00 4.73721e-02 0.00000e+00 -2169 4.65000e+00 1.33975e-01 0.00000e+00 -2170 4.62500e+00 5.23686e-01 0.00000e+00 -2171 4.65000e+00 2.20577e-01 0.00000e+00 -2172 4.57500e+00 8.70096e-01 0.00000e+00 -2173 4.55000e+00 1.00000e+00 0.00000e+00 -2174 4.60000e+00 7.40192e-01 0.00000e+00 -2175 4.65000e+00 3.07180e-01 0.00000e+00 -2176 4.62500e+00 6.10289e-01 0.00000e+00 -2177 4.65000e+00 3.93782e-01 0.00000e+00 -2178 4.60000e+00 8.26795e-01 0.00000e+00 -2179 4.57500e+00 9.56699e-01 0.00000e+00 -2180 4.65000e+00 4.80385e-01 0.00000e+00 -2181 4.67500e+00 9.06733e-02 0.00000e+00 -2182 4.62500e+00 6.96891e-01 0.00000e+00 -2183 4.67500e+00 1.77276e-01 0.00000e+00 -2184 4.67500e+00 2.63878e-01 0.00000e+00 -2185 4.65000e+00 5.66987e-01 0.00000e+00 -2186 4.67500e+00 3.50481e-01 0.00000e+00 -2187 4.60000e+00 9.13397e-01 0.00000e+00 -2188 4.62500e+00 7.83494e-01 0.00000e+00 -2189 4.67500e+00 4.37083e-01 0.00000e+00 -2190 4.65000e+00 6.53590e-01 0.00000e+00 -2191 4.70000e+00 0.00000e+00 0.00000e+00 -2192 4.70000e+00 4.73721e-02 0.00000e+00 -2193 4.70000e+00 1.33975e-01 0.00000e+00 -2194 4.67500e+00 5.23686e-01 0.00000e+00 -2195 4.70000e+00 2.20577e-01 0.00000e+00 -2196 4.62500e+00 8.70096e-01 0.00000e+00 -2197 4.60000e+00 1.00000e+00 0.00000e+00 -2198 4.65000e+00 7.40192e-01 0.00000e+00 -2199 4.70000e+00 3.07180e-01 0.00000e+00 -2200 4.67500e+00 6.10289e-01 0.00000e+00 -2201 4.70000e+00 3.93782e-01 0.00000e+00 -2202 4.62500e+00 9.56699e-01 0.00000e+00 -2203 4.65000e+00 8.26795e-01 0.00000e+00 -2204 4.70000e+00 4.80385e-01 0.00000e+00 -2205 4.72500e+00 9.06733e-02 0.00000e+00 -2206 4.67500e+00 6.96891e-01 0.00000e+00 -2207 4.72500e+00 1.77276e-01 0.00000e+00 -2208 4.72500e+00 2.63878e-01 0.00000e+00 -2209 4.70000e+00 5.66987e-01 0.00000e+00 -2210 4.72500e+00 3.50481e-01 0.00000e+00 -2211 4.65000e+00 9.13397e-01 0.00000e+00 -2212 4.67500e+00 7.83494e-01 0.00000e+00 -2213 4.72500e+00 4.37083e-01 0.00000e+00 -2214 4.70000e+00 6.53590e-01 0.00000e+00 -2215 4.75000e+00 0.00000e+00 0.00000e+00 -2216 4.75000e+00 4.73721e-02 0.00000e+00 -2217 4.75000e+00 1.33975e-01 0.00000e+00 -2218 4.72500e+00 5.23686e-01 0.00000e+00 -2219 4.75000e+00 2.20577e-01 0.00000e+00 -2220 4.67500e+00 8.70096e-01 0.00000e+00 -2221 4.65000e+00 1.00000e+00 0.00000e+00 -2222 4.70000e+00 7.40192e-01 0.00000e+00 -2223 4.75000e+00 3.07180e-01 0.00000e+00 -2224 4.72500e+00 6.10289e-01 0.00000e+00 -2225 4.75000e+00 3.93782e-01 0.00000e+00 -2226 4.67500e+00 9.56699e-01 0.00000e+00 -2227 4.70000e+00 8.26795e-01 0.00000e+00 -2228 4.75000e+00 4.80385e-01 0.00000e+00 -2229 4.77500e+00 9.06733e-02 0.00000e+00 -2230 4.72500e+00 6.96891e-01 0.00000e+00 -2231 4.77500e+00 1.77276e-01 0.00000e+00 -2232 4.77500e+00 2.63878e-01 0.00000e+00 -2233 4.75000e+00 5.66987e-01 0.00000e+00 -2234 4.77500e+00 3.50481e-01 0.00000e+00 -2235 4.70000e+00 9.13397e-01 0.00000e+00 -2236 4.72500e+00 7.83494e-01 0.00000e+00 -2237 4.75000e+00 6.53590e-01 0.00000e+00 -2238 4.77500e+00 4.37083e-01 0.00000e+00 -2239 4.80000e+00 0.00000e+00 0.00000e+00 -2240 4.80000e+00 4.73721e-02 0.00000e+00 -2241 4.80000e+00 1.33975e-01 0.00000e+00 -2242 4.77500e+00 5.23686e-01 0.00000e+00 -2243 4.72500e+00 8.70096e-01 0.00000e+00 -2244 4.80000e+00 2.20577e-01 0.00000e+00 -2245 4.70000e+00 1.00000e+00 0.00000e+00 -2246 4.75000e+00 7.40192e-01 0.00000e+00 -2247 4.80000e+00 3.07180e-01 0.00000e+00 -2248 4.77500e+00 6.10289e-01 0.00000e+00 -2249 4.80000e+00 3.93782e-01 0.00000e+00 -2250 4.72500e+00 9.56699e-01 0.00000e+00 -2251 4.75000e+00 8.26795e-01 0.00000e+00 -2252 4.80000e+00 4.80385e-01 0.00000e+00 -2253 4.77500e+00 6.96891e-01 0.00000e+00 -2254 4.82500e+00 9.06733e-02 0.00000e+00 -2255 4.82500e+00 1.77276e-01 0.00000e+00 -2256 4.82500e+00 2.63878e-01 0.00000e+00 -2257 4.80000e+00 5.66987e-01 0.00000e+00 -2258 4.75000e+00 9.13397e-01 0.00000e+00 -2259 4.82500e+00 3.50481e-01 0.00000e+00 -2260 4.77500e+00 7.83494e-01 0.00000e+00 -2261 4.80000e+00 6.53590e-01 0.00000e+00 -2262 4.82500e+00 4.37083e-01 0.00000e+00 -2263 4.85000e+00 0.00000e+00 0.00000e+00 -2264 4.85000e+00 4.73721e-02 0.00000e+00 -2265 4.85000e+00 1.33975e-01 0.00000e+00 -2266 4.82500e+00 5.23686e-01 0.00000e+00 -2267 4.77500e+00 8.70096e-01 0.00000e+00 -2268 4.75000e+00 1.00000e+00 0.00000e+00 -2269 4.85000e+00 2.20577e-01 0.00000e+00 -2270 4.80000e+00 7.40192e-01 0.00000e+00 -2271 4.85000e+00 3.07180e-01 0.00000e+00 -2272 4.82500e+00 6.10289e-01 0.00000e+00 -2273 4.85000e+00 3.93782e-01 0.00000e+00 -2274 4.77500e+00 9.56699e-01 0.00000e+00 -2275 4.80000e+00 8.26795e-01 0.00000e+00 -2276 4.85000e+00 4.80385e-01 0.00000e+00 -2277 4.82500e+00 6.96891e-01 0.00000e+00 -2278 4.87500e+00 9.06733e-02 0.00000e+00 -2279 4.87500e+00 1.77276e-01 0.00000e+00 -2280 4.87500e+00 2.63878e-01 0.00000e+00 -2281 4.85000e+00 5.66987e-01 0.00000e+00 -2282 4.80000e+00 9.13397e-01 0.00000e+00 -2283 4.87500e+00 3.50481e-01 0.00000e+00 -2284 4.82500e+00 7.83494e-01 0.00000e+00 -2285 4.85000e+00 6.53590e-01 0.00000e+00 -2286 4.87500e+00 4.37083e-01 0.00000e+00 -2287 4.90000e+00 0.00000e+00 0.00000e+00 -2288 4.90000e+00 4.73721e-02 0.00000e+00 -2289 4.90000e+00 1.33975e-01 0.00000e+00 -2290 4.82500e+00 8.70096e-01 0.00000e+00 -2291 4.87500e+00 5.23686e-01 0.00000e+00 -2292 4.80000e+00 1.00000e+00 0.00000e+00 -2293 4.90000e+00 2.20577e-01 0.00000e+00 -2294 4.85000e+00 7.40192e-01 0.00000e+00 -2295 4.90000e+00 3.07180e-01 0.00000e+00 -2296 4.87500e+00 6.10289e-01 0.00000e+00 -2297 4.90000e+00 3.93782e-01 0.00000e+00 -2298 4.82500e+00 9.56699e-01 0.00000e+00 -2299 4.85000e+00 8.26795e-01 0.00000e+00 -2300 4.90000e+00 4.80385e-01 0.00000e+00 -2301 4.87500e+00 6.96891e-01 0.00000e+00 -2302 4.92500e+00 9.06733e-02 0.00000e+00 -2303 4.92500e+00 1.77276e-01 0.00000e+00 -2304 4.92500e+00 2.63878e-01 0.00000e+00 -2305 4.90000e+00 5.66987e-01 0.00000e+00 -2306 4.85000e+00 9.13397e-01 0.00000e+00 -2307 4.92500e+00 3.50481e-01 0.00000e+00 -2308 4.87500e+00 7.83494e-01 0.00000e+00 -2309 4.90000e+00 6.53590e-01 0.00000e+00 -2310 4.92500e+00 4.37083e-01 0.00000e+00 -2311 4.95000e+00 0.00000e+00 0.00000e+00 -2312 4.95000e+00 4.73721e-02 0.00000e+00 -2313 4.95000e+00 1.33975e-01 0.00000e+00 -2314 4.85000e+00 1.00000e+00 0.00000e+00 -2315 4.87500e+00 8.70096e-01 0.00000e+00 -2316 4.92500e+00 5.23686e-01 0.00000e+00 -2317 4.95000e+00 2.20577e-01 0.00000e+00 -2318 4.90000e+00 7.40192e-01 0.00000e+00 -2319 4.95000e+00 3.07180e-01 0.00000e+00 -2320 4.92500e+00 6.10289e-01 0.00000e+00 -2321 4.95000e+00 3.93782e-01 0.00000e+00 -2322 4.87500e+00 9.56699e-01 0.00000e+00 -2323 4.90000e+00 8.26795e-01 0.00000e+00 -2324 4.95000e+00 4.80385e-01 0.00000e+00 -2325 4.92500e+00 6.96891e-01 0.00000e+00 -2326 4.97500e+00 9.06733e-02 0.00000e+00 -2327 4.97500e+00 1.77276e-01 0.00000e+00 -2328 4.97500e+00 2.63878e-01 0.00000e+00 -2329 4.95000e+00 5.66987e-01 0.00000e+00 -2330 4.90000e+00 9.13397e-01 0.00000e+00 -2331 4.92500e+00 7.83494e-01 0.00000e+00 -2332 4.97500e+00 3.50481e-01 0.00000e+00 -2333 4.95000e+00 6.53590e-01 0.00000e+00 -2334 4.97500e+00 4.37083e-01 0.00000e+00 -2335 5.00000e+00 0.00000e+00 0.00000e+00 -2336 5.00000e+00 4.73721e-02 0.00000e+00 -2337 4.90000e+00 1.00000e+00 0.00000e+00 -2338 4.92500e+00 8.70096e-01 0.00000e+00 -2339 5.00000e+00 1.33975e-01 0.00000e+00 -2340 4.97500e+00 5.23686e-01 0.00000e+00 -2341 5.00000e+00 2.20577e-01 0.00000e+00 -2342 4.95000e+00 7.40192e-01 0.00000e+00 -2343 5.00000e+00 3.07180e-01 0.00000e+00 -2344 4.97500e+00 6.10289e-01 0.00000e+00 -2345 5.00000e+00 3.93782e-01 0.00000e+00 -2346 4.92500e+00 9.56699e-01 0.00000e+00 -2347 4.95000e+00 8.26795e-01 0.00000e+00 -2348 5.00000e+00 4.80385e-01 0.00000e+00 -2349 4.97500e+00 6.96891e-01 0.00000e+00 -2350 5.02500e+00 9.06733e-02 0.00000e+00 -2351 5.02500e+00 1.77276e-01 0.00000e+00 -2352 5.02500e+00 2.63878e-01 0.00000e+00 -2353 5.00000e+00 5.66987e-01 0.00000e+00 -2354 4.95000e+00 9.13397e-01 0.00000e+00 -2355 4.97500e+00 7.83494e-01 0.00000e+00 -2356 5.02500e+00 3.50481e-01 0.00000e+00 -2357 5.00000e+00 6.53590e-01 0.00000e+00 -2358 5.02500e+00 4.37083e-01 0.00000e+00 -2359 4.95000e+00 1.00000e+00 0.00000e+00 -2360 5.05000e+00 0.00000e+00 0.00000e+00 -2361 5.05000e+00 4.73721e-02 0.00000e+00 -2362 4.97500e+00 8.70096e-01 0.00000e+00 -2363 5.05000e+00 1.33975e-01 0.00000e+00 -2364 5.02500e+00 5.23686e-01 0.00000e+00 -2365 5.00000e+00 7.40192e-01 0.00000e+00 -2366 5.05000e+00 2.20577e-01 0.00000e+00 -2367 5.05000e+00 3.07180e-01 0.00000e+00 -2368 5.02500e+00 6.10289e-01 0.00000e+00 -2369 5.05000e+00 3.93782e-01 0.00000e+00 -2370 4.97500e+00 9.56699e-01 0.00000e+00 -2371 5.00000e+00 8.26795e-01 0.00000e+00 -2372 5.05000e+00 4.80385e-01 0.00000e+00 -2373 5.02500e+00 6.96891e-01 0.00000e+00 -2374 5.07500e+00 9.06733e-02 0.00000e+00 -2375 5.07500e+00 1.77276e-01 0.00000e+00 -2376 5.05000e+00 5.66987e-01 0.00000e+00 -2377 5.07500e+00 2.63878e-01 0.00000e+00 -2378 5.00000e+00 9.13397e-01 0.00000e+00 -2379 5.02500e+00 7.83494e-01 0.00000e+00 -2380 5.07500e+00 3.50481e-01 0.00000e+00 -2381 5.05000e+00 6.53590e-01 0.00000e+00 -2382 5.07500e+00 4.37083e-01 0.00000e+00 -2383 5.00000e+00 1.00000e+00 0.00000e+00 -2384 5.02500e+00 8.70096e-01 0.00000e+00 -2385 5.10000e+00 0.00000e+00 0.00000e+00 -2386 5.10000e+00 4.73721e-02 0.00000e+00 -2387 5.10000e+00 1.33975e-01 0.00000e+00 -2388 5.07500e+00 5.23686e-01 0.00000e+00 -2389 5.05000e+00 7.40192e-01 0.00000e+00 -2390 5.10000e+00 2.20577e-01 0.00000e+00 -2391 5.10000e+00 3.07180e-01 0.00000e+00 -2392 5.07500e+00 6.10289e-01 0.00000e+00 -2393 5.10000e+00 3.93782e-01 0.00000e+00 -2394 5.02500e+00 9.56699e-01 0.00000e+00 -2395 5.05000e+00 8.26795e-01 0.00000e+00 -2396 5.10000e+00 4.80385e-01 0.00000e+00 -2397 5.07500e+00 6.96891e-01 0.00000e+00 -2398 5.12500e+00 9.06733e-02 0.00000e+00 -2399 5.12500e+00 1.77276e-01 0.00000e+00 -2400 5.10000e+00 5.66987e-01 0.00000e+00 -2401 5.12500e+00 2.63878e-01 0.00000e+00 -2402 5.05000e+00 9.13397e-01 0.00000e+00 -2403 5.07500e+00 7.83494e-01 0.00000e+00 -2404 5.12500e+00 3.50481e-01 0.00000e+00 -2405 5.10000e+00 6.53590e-01 0.00000e+00 -2406 5.12500e+00 4.37083e-01 0.00000e+00 -2407 5.05000e+00 1.00000e+00 0.00000e+00 -2408 5.07500e+00 8.70096e-01 0.00000e+00 -2409 5.15000e+00 0.00000e+00 0.00000e+00 -2410 5.15000e+00 4.73721e-02 0.00000e+00 -2411 5.12500e+00 5.23686e-01 0.00000e+00 -2412 5.15000e+00 1.33975e-01 0.00000e+00 -2413 5.10000e+00 7.40192e-01 0.00000e+00 -2414 5.15000e+00 2.20577e-01 0.00000e+00 -2415 5.15000e+00 3.07180e-01 0.00000e+00 -2416 5.12500e+00 6.10289e-01 0.00000e+00 -2417 5.07500e+00 9.56699e-01 0.00000e+00 -2418 5.15000e+00 3.93782e-01 0.00000e+00 -2419 5.10000e+00 8.26795e-01 0.00000e+00 -2420 5.12500e+00 6.96891e-01 0.00000e+00 -2421 5.15000e+00 4.80385e-01 0.00000e+00 -2422 5.17500e+00 9.06733e-02 0.00000e+00 -2423 5.17500e+00 1.77276e-01 0.00000e+00 -2424 5.15000e+00 5.66987e-01 0.00000e+00 -2425 5.10000e+00 9.13397e-01 0.00000e+00 -2426 5.17500e+00 2.63878e-01 0.00000e+00 -2427 5.12500e+00 7.83494e-01 0.00000e+00 -2428 5.17500e+00 3.50481e-01 0.00000e+00 -2429 5.15000e+00 6.53590e-01 0.00000e+00 -2430 5.17500e+00 4.37083e-01 0.00000e+00 -2431 5.10000e+00 1.00000e+00 0.00000e+00 -2432 5.12500e+00 8.70096e-01 0.00000e+00 -2433 5.20000e+00 0.00000e+00 0.00000e+00 -2434 5.20000e+00 4.73721e-02 0.00000e+00 -2435 5.17500e+00 5.23686e-01 0.00000e+00 -2436 5.20000e+00 1.33975e-01 0.00000e+00 -2437 5.15000e+00 7.40192e-01 0.00000e+00 -2438 5.20000e+00 2.20577e-01 0.00000e+00 -2439 5.20000e+00 3.07180e-01 0.00000e+00 -2440 5.17500e+00 6.10289e-01 0.00000e+00 -2441 5.12500e+00 9.56699e-01 0.00000e+00 -2442 5.20000e+00 3.93782e-01 0.00000e+00 -2443 5.15000e+00 8.26795e-01 0.00000e+00 -2444 5.17500e+00 6.96891e-01 0.00000e+00 -2445 5.20000e+00 4.80385e-01 0.00000e+00 -2446 5.22500e+00 9.06733e-02 0.00000e+00 -2447 5.22500e+00 1.77276e-01 0.00000e+00 -2448 5.15000e+00 9.13397e-01 0.00000e+00 -2449 5.20000e+00 5.66987e-01 0.00000e+00 -2450 5.22500e+00 2.63878e-01 0.00000e+00 -2451 5.17500e+00 7.83494e-01 0.00000e+00 -2452 5.22500e+00 3.50481e-01 0.00000e+00 -2453 5.20000e+00 6.53590e-01 0.00000e+00 -2454 5.22500e+00 4.37083e-01 0.00000e+00 -2455 5.15000e+00 1.00000e+00 0.00000e+00 -2456 5.17500e+00 8.70096e-01 0.00000e+00 -2457 5.25000e+00 0.00000e+00 0.00000e+00 -2458 5.25000e+00 4.73721e-02 0.00000e+00 -2459 5.22500e+00 5.23686e-01 0.00000e+00 -2460 5.25000e+00 1.33975e-01 0.00000e+00 -2461 5.20000e+00 7.40192e-01 0.00000e+00 -2462 5.25000e+00 2.20577e-01 0.00000e+00 -2463 5.25000e+00 3.07180e-01 0.00000e+00 -2464 5.22500e+00 6.10289e-01 0.00000e+00 -2465 5.17500e+00 9.56699e-01 0.00000e+00 -2466 5.25000e+00 3.93782e-01 0.00000e+00 -2467 5.20000e+00 8.26795e-01 0.00000e+00 -2468 5.22500e+00 6.96891e-01 0.00000e+00 -2469 5.25000e+00 4.80385e-01 0.00000e+00 -2470 5.27500e+00 9.06733e-02 0.00000e+00 -2471 5.27500e+00 1.77276e-01 0.00000e+00 -2472 5.20000e+00 9.13397e-01 0.00000e+00 -2473 5.25000e+00 5.66987e-01 0.00000e+00 -2474 5.27500e+00 2.63878e-01 0.00000e+00 -2475 5.22500e+00 7.83494e-01 0.00000e+00 -2476 5.27500e+00 3.50481e-01 0.00000e+00 -2477 5.25000e+00 6.53590e-01 0.00000e+00 -2478 5.27500e+00 4.37083e-01 0.00000e+00 -2479 5.20000e+00 1.00000e+00 0.00000e+00 -2480 5.22500e+00 8.70096e-01 0.00000e+00 -2481 5.30000e+00 0.00000e+00 0.00000e+00 -2482 5.30000e+00 4.73721e-02 0.00000e+00 -2483 5.27500e+00 5.23686e-01 0.00000e+00 -2484 5.30000e+00 1.33975e-01 0.00000e+00 -2485 5.25000e+00 7.40192e-01 0.00000e+00 -2486 5.30000e+00 2.20577e-01 0.00000e+00 -2487 5.30000e+00 3.07180e-01 0.00000e+00 -2488 5.27500e+00 6.10289e-01 0.00000e+00 -2489 5.22500e+00 9.56699e-01 0.00000e+00 -2490 5.30000e+00 3.93782e-01 0.00000e+00 -2491 5.25000e+00 8.26795e-01 0.00000e+00 -2492 5.27500e+00 6.96891e-01 0.00000e+00 -2493 5.30000e+00 4.80385e-01 0.00000e+00 -2494 5.32500e+00 9.06733e-02 0.00000e+00 -2495 5.32500e+00 1.77276e-01 0.00000e+00 -2496 5.25000e+00 9.13397e-01 0.00000e+00 -2497 5.30000e+00 5.66987e-01 0.00000e+00 -2498 5.32500e+00 2.63878e-01 0.00000e+00 -2499 5.27500e+00 7.83494e-01 0.00000e+00 -2500 5.32500e+00 3.50481e-01 0.00000e+00 -2501 5.30000e+00 6.53590e-01 0.00000e+00 -2502 5.32500e+00 4.37083e-01 0.00000e+00 -2503 5.25000e+00 1.00000e+00 0.00000e+00 -2504 5.27500e+00 8.70096e-01 0.00000e+00 -2505 5.35000e+00 0.00000e+00 0.00000e+00 -2506 5.35000e+00 4.73721e-02 0.00000e+00 -2507 5.32500e+00 5.23686e-01 0.00000e+00 -2508 5.30000e+00 7.40192e-01 0.00000e+00 -2509 5.35000e+00 1.33975e-01 0.00000e+00 -2510 5.35000e+00 2.20577e-01 0.00000e+00 -2511 5.35000e+00 3.07180e-01 0.00000e+00 -2512 5.32500e+00 6.10289e-01 0.00000e+00 -2513 5.27500e+00 9.56699e-01 0.00000e+00 -2514 5.30000e+00 8.26795e-01 0.00000e+00 -2515 5.35000e+00 3.93782e-01 0.00000e+00 -2516 5.32500e+00 6.96891e-01 0.00000e+00 -2517 5.35000e+00 4.80385e-01 0.00000e+00 -2518 5.37500e+00 9.06733e-02 0.00000e+00 -2519 5.37500e+00 1.77276e-01 0.00000e+00 -2520 5.30000e+00 9.13397e-01 0.00000e+00 -2521 5.35000e+00 5.66987e-01 0.00000e+00 -2522 5.37500e+00 2.63878e-01 0.00000e+00 -2523 5.32500e+00 7.83494e-01 0.00000e+00 -2524 5.37500e+00 3.50481e-01 0.00000e+00 -2525 5.35000e+00 6.53590e-01 0.00000e+00 -2526 5.37500e+00 4.37083e-01 0.00000e+00 -2527 5.30000e+00 1.00000e+00 0.00000e+00 -2528 5.32500e+00 8.70096e-01 0.00000e+00 -2529 5.40000e+00 0.00000e+00 0.00000e+00 -2530 5.40000e+00 4.73721e-02 0.00000e+00 -2531 5.37500e+00 5.23686e-01 0.00000e+00 -2532 5.35000e+00 7.40192e-01 0.00000e+00 -2533 5.40000e+00 1.33975e-01 0.00000e+00 -2534 5.40000e+00 2.20577e-01 0.00000e+00 -2535 5.40000e+00 3.07180e-01 0.00000e+00 -2536 5.37500e+00 6.10289e-01 0.00000e+00 -2537 5.32500e+00 9.56699e-01 0.00000e+00 -2538 5.35000e+00 8.26795e-01 0.00000e+00 -2539 5.40000e+00 3.93782e-01 0.00000e+00 -2540 5.37500e+00 6.96891e-01 0.00000e+00 -2541 5.40000e+00 4.80385e-01 0.00000e+00 -2542 5.42500e+00 9.06733e-02 0.00000e+00 -2543 5.35000e+00 9.13397e-01 0.00000e+00 -2544 5.42500e+00 1.77276e-01 0.00000e+00 -2545 5.40000e+00 5.66987e-01 0.00000e+00 -2546 5.42500e+00 2.63878e-01 0.00000e+00 -2547 5.37500e+00 7.83494e-01 0.00000e+00 -2548 5.42500e+00 3.50481e-01 0.00000e+00 -2549 5.40000e+00 6.53590e-01 0.00000e+00 -2550 5.42500e+00 4.37083e-01 0.00000e+00 -2551 5.35000e+00 1.00000e+00 0.00000e+00 -2552 5.37500e+00 8.70096e-01 0.00000e+00 -2553 5.45000e+00 0.00000e+00 0.00000e+00 -2554 5.45000e+00 4.73721e-02 0.00000e+00 -2555 5.42500e+00 5.23686e-01 0.00000e+00 -2556 5.40000e+00 7.40192e-01 0.00000e+00 -2557 5.45000e+00 1.33975e-01 0.00000e+00 -2558 5.45000e+00 2.20577e-01 0.00000e+00 -2559 5.45000e+00 3.07180e-01 0.00000e+00 -2560 5.42500e+00 6.10289e-01 0.00000e+00 -2561 5.37500e+00 9.56699e-01 0.00000e+00 -2562 5.40000e+00 8.26795e-01 0.00000e+00 -2563 5.45000e+00 3.93782e-01 0.00000e+00 -2564 5.42500e+00 6.96891e-01 0.00000e+00 -2565 5.45000e+00 4.80385e-01 0.00000e+00 -2566 5.47500e+00 9.06733e-02 0.00000e+00 -2567 5.40000e+00 9.13397e-01 0.00000e+00 -2568 5.47500e+00 1.77276e-01 0.00000e+00 -2569 5.45000e+00 5.66987e-01 0.00000e+00 -2570 5.42500e+00 7.83494e-01 0.00000e+00 -2571 5.47500e+00 2.63878e-01 0.00000e+00 -2572 5.47500e+00 3.50481e-01 0.00000e+00 -2573 5.45000e+00 6.53590e-01 0.00000e+00 -2574 5.40000e+00 1.00000e+00 0.00000e+00 -2575 5.47500e+00 4.37083e-01 0.00000e+00 -2576 5.42500e+00 8.70096e-01 0.00000e+00 -2577 5.47500e+00 5.23686e-01 0.00000e+00 -2578 5.50000e+00 0.00000e+00 0.00000e+00 -2579 5.45000e+00 7.40192e-01 0.00000e+00 -2580 5.50000e+00 4.73721e-02 0.00000e+00 -2581 5.50000e+00 1.33975e-01 0.00000e+00 -2582 5.50000e+00 2.20577e-01 0.00000e+00 -2583 5.50000e+00 3.07180e-01 0.00000e+00 -2584 5.42500e+00 9.56699e-01 0.00000e+00 -2585 5.47500e+00 6.10289e-01 0.00000e+00 -2586 5.45000e+00 8.26795e-01 0.00000e+00 -2587 5.50000e+00 3.93782e-01 0.00000e+00 -2588 5.47500e+00 6.96891e-01 0.00000e+00 -2589 5.50000e+00 4.80385e-01 0.00000e+00 -2590 5.52500e+00 9.06733e-02 0.00000e+00 -2591 5.45000e+00 9.13397e-01 0.00000e+00 -2592 5.52500e+00 1.77276e-01 0.00000e+00 -2593 5.50000e+00 5.66987e-01 0.00000e+00 -2594 5.47500e+00 7.83494e-01 0.00000e+00 -2595 5.52500e+00 2.63878e-01 0.00000e+00 -2596 5.52500e+00 3.50481e-01 0.00000e+00 -2597 5.50000e+00 6.53590e-01 0.00000e+00 -2598 5.45000e+00 1.00000e+00 0.00000e+00 -2599 5.52500e+00 4.37083e-01 0.00000e+00 -2600 5.47500e+00 8.70096e-01 0.00000e+00 -2601 5.50000e+00 7.40192e-01 0.00000e+00 -2602 5.52500e+00 5.23686e-01 0.00000e+00 -2603 5.55000e+00 0.00000e+00 0.00000e+00 -2604 5.55000e+00 4.73721e-02 0.00000e+00 -2605 5.55000e+00 1.33975e-01 0.00000e+00 -2606 5.55000e+00 2.20577e-01 0.00000e+00 -2607 5.47500e+00 9.56699e-01 0.00000e+00 -2608 5.55000e+00 3.07180e-01 0.00000e+00 -2609 5.52500e+00 6.10289e-01 0.00000e+00 -2610 5.50000e+00 8.26795e-01 0.00000e+00 -2611 5.55000e+00 3.93782e-01 0.00000e+00 -2612 5.52500e+00 6.96891e-01 0.00000e+00 -2613 5.55000e+00 4.80385e-01 0.00000e+00 -2614 5.50000e+00 9.13397e-01 0.00000e+00 -2615 5.57500e+00 9.06733e-02 0.00000e+00 -2616 5.57500e+00 1.77276e-01 0.00000e+00 -2617 5.55000e+00 5.66987e-01 0.00000e+00 -2618 5.52500e+00 7.83494e-01 0.00000e+00 -2619 5.57500e+00 2.63878e-01 0.00000e+00 -2620 5.57500e+00 3.50481e-01 0.00000e+00 -2621 5.55000e+00 6.53590e-01 0.00000e+00 -2622 5.50000e+00 1.00000e+00 0.00000e+00 -2623 5.57500e+00 4.37083e-01 0.00000e+00 -2624 5.52500e+00 8.70096e-01 0.00000e+00 -2625 5.55000e+00 7.40192e-01 0.00000e+00 -2626 5.57500e+00 5.23686e-01 0.00000e+00 -2627 5.60000e+00 0.00000e+00 0.00000e+00 -2628 5.60000e+00 4.73721e-02 0.00000e+00 -2629 5.60000e+00 1.33975e-01 0.00000e+00 -2630 5.60000e+00 2.20577e-01 0.00000e+00 -2631 5.52500e+00 9.56699e-01 0.00000e+00 -2632 5.57500e+00 6.10289e-01 0.00000e+00 -2633 5.60000e+00 3.07180e-01 0.00000e+00 -2634 5.55000e+00 8.26795e-01 0.00000e+00 -2635 5.60000e+00 3.93782e-01 0.00000e+00 -2636 5.57500e+00 6.96891e-01 0.00000e+00 -2637 5.60000e+00 4.80385e-01 0.00000e+00 -2638 5.55000e+00 9.13397e-01 0.00000e+00 -2639 5.62500e+00 9.06733e-02 0.00000e+00 -2640 5.62500e+00 1.77276e-01 0.00000e+00 -2641 5.60000e+00 5.66987e-01 0.00000e+00 -2642 5.57500e+00 7.83494e-01 0.00000e+00 -2643 5.62500e+00 2.63878e-01 0.00000e+00 -2644 5.62500e+00 3.50481e-01 0.00000e+00 -2645 5.60000e+00 6.53590e-01 0.00000e+00 -2646 5.55000e+00 1.00000e+00 0.00000e+00 -2647 5.62500e+00 4.37083e-01 0.00000e+00 -2648 5.57500e+00 8.70096e-01 0.00000e+00 -2649 5.60000e+00 7.40192e-01 0.00000e+00 -2650 5.62500e+00 5.23686e-01 0.00000e+00 -2651 5.65000e+00 0.00000e+00 0.00000e+00 -2652 5.65000e+00 4.73721e-02 0.00000e+00 -2653 5.65000e+00 1.33975e-01 0.00000e+00 -2654 5.65000e+00 2.20577e-01 0.00000e+00 -2655 5.57500e+00 9.56699e-01 0.00000e+00 -2656 5.62500e+00 6.10289e-01 0.00000e+00 -2657 5.65000e+00 3.07180e-01 0.00000e+00 -2658 5.60000e+00 8.26795e-01 0.00000e+00 -2659 5.65000e+00 3.93782e-01 0.00000e+00 -2660 5.62500e+00 6.96891e-01 0.00000e+00 -2661 5.65000e+00 4.80385e-01 0.00000e+00 -2662 5.60000e+00 9.13397e-01 0.00000e+00 -2663 5.67500e+00 9.06733e-02 0.00000e+00 -2664 5.67500e+00 1.77276e-01 0.00000e+00 -2665 5.65000e+00 5.66987e-01 0.00000e+00 -2666 5.62500e+00 7.83494e-01 0.00000e+00 -2667 5.67500e+00 2.63878e-01 0.00000e+00 -2668 5.67500e+00 3.50481e-01 0.00000e+00 -2669 5.65000e+00 6.53590e-01 0.00000e+00 -2670 5.60000e+00 1.00000e+00 0.00000e+00 -2671 5.67500e+00 4.37083e-01 0.00000e+00 -2672 5.62500e+00 8.70096e-01 0.00000e+00 -2673 5.65000e+00 7.40192e-01 0.00000e+00 -2674 5.67500e+00 5.23686e-01 0.00000e+00 -2675 5.70000e+00 0.00000e+00 0.00000e+00 -2676 5.70000e+00 4.73721e-02 0.00000e+00 -2677 5.70000e+00 1.33975e-01 0.00000e+00 -2678 5.70000e+00 2.20577e-01 0.00000e+00 -2679 5.62500e+00 9.56699e-01 0.00000e+00 -2680 5.67500e+00 6.10289e-01 0.00000e+00 -2681 5.70000e+00 3.07180e-01 0.00000e+00 -2682 5.65000e+00 8.26795e-01 0.00000e+00 -2683 5.70000e+00 3.93782e-01 0.00000e+00 -2684 5.67500e+00 6.96891e-01 0.00000e+00 -2685 5.70000e+00 4.80385e-01 0.00000e+00 -2686 5.65000e+00 9.13397e-01 0.00000e+00 -2687 5.72500e+00 9.06733e-02 0.00000e+00 -2688 5.72500e+00 1.77276e-01 0.00000e+00 -2689 5.70000e+00 5.66987e-01 0.00000e+00 -2690 5.67500e+00 7.83494e-01 0.00000e+00 -2691 5.72500e+00 2.63878e-01 0.00000e+00 -2692 5.72500e+00 3.50481e-01 0.00000e+00 -2693 5.70000e+00 6.53590e-01 0.00000e+00 -2694 5.65000e+00 1.00000e+00 0.00000e+00 -2695 5.67500e+00 8.70096e-01 0.00000e+00 -2696 5.72500e+00 4.37083e-01 0.00000e+00 -2697 5.70000e+00 7.40192e-01 0.00000e+00 -2698 5.72500e+00 5.23686e-01 0.00000e+00 -2699 5.75000e+00 0.00000e+00 0.00000e+00 -2700 5.75000e+00 4.73721e-02 0.00000e+00 -2701 5.75000e+00 1.33975e-01 0.00000e+00 -2702 5.75000e+00 2.20577e-01 0.00000e+00 -2703 5.67500e+00 9.56699e-01 0.00000e+00 -2704 5.72500e+00 6.10289e-01 0.00000e+00 -2705 5.75000e+00 3.07180e-01 0.00000e+00 -2706 5.70000e+00 8.26795e-01 0.00000e+00 -2707 5.75000e+00 3.93782e-01 0.00000e+00 -2708 5.72500e+00 6.96891e-01 0.00000e+00 -2709 5.75000e+00 4.80385e-01 0.00000e+00 -2710 5.70000e+00 9.13397e-01 0.00000e+00 -2711 5.77500e+00 9.06733e-02 0.00000e+00 -2712 5.77500e+00 1.77276e-01 0.00000e+00 -2713 5.75000e+00 5.66987e-01 0.00000e+00 -2714 5.72500e+00 7.83494e-01 0.00000e+00 -2715 5.77500e+00 2.63878e-01 0.00000e+00 -2716 5.77500e+00 3.50481e-01 0.00000e+00 -2717 5.75000e+00 6.53590e-01 0.00000e+00 -2718 5.70000e+00 1.00000e+00 0.00000e+00 -2719 5.72500e+00 8.70096e-01 0.00000e+00 -2720 5.77500e+00 4.37083e-01 0.00000e+00 -2721 5.75000e+00 7.40192e-01 0.00000e+00 -2722 5.77500e+00 5.23686e-01 0.00000e+00 -2723 5.80000e+00 0.00000e+00 0.00000e+00 -2724 5.80000e+00 4.73721e-02 0.00000e+00 -2725 5.80000e+00 1.33975e-01 0.00000e+00 -2726 5.80000e+00 2.20577e-01 0.00000e+00 -2727 5.72500e+00 9.56699e-01 0.00000e+00 -2728 5.77500e+00 6.10289e-01 0.00000e+00 -2729 5.80000e+00 3.07180e-01 0.00000e+00 -2730 5.75000e+00 8.26795e-01 0.00000e+00 -2731 5.80000e+00 3.93782e-01 0.00000e+00 -2732 5.77500e+00 6.96891e-01 0.00000e+00 -2733 5.80000e+00 4.80385e-01 0.00000e+00 -2734 5.75000e+00 9.13397e-01 0.00000e+00 -2735 5.82500e+00 9.06733e-02 0.00000e+00 -2736 5.80000e+00 5.66987e-01 0.00000e+00 -2737 5.82500e+00 1.77276e-01 0.00000e+00 -2738 5.77500e+00 7.83494e-01 0.00000e+00 -2739 5.82500e+00 2.63878e-01 0.00000e+00 -2740 5.82500e+00 3.50481e-01 0.00000e+00 -2741 5.75000e+00 1.00000e+00 0.00000e+00 -2742 5.80000e+00 6.53590e-01 0.00000e+00 -2743 5.77500e+00 8.70096e-01 0.00000e+00 -2744 5.82500e+00 4.37083e-01 0.00000e+00 -2745 5.80000e+00 7.40192e-01 0.00000e+00 -2746 5.82500e+00 5.23686e-01 0.00000e+00 -2747 5.85000e+00 0.00000e+00 0.00000e+00 -2748 5.85000e+00 4.73721e-02 0.00000e+00 -2749 5.85000e+00 1.33975e-01 0.00000e+00 -2750 5.77500e+00 9.56699e-01 0.00000e+00 -2751 5.85000e+00 2.20577e-01 0.00000e+00 -2752 5.85000e+00 3.07180e-01 0.00000e+00 -2753 5.80000e+00 8.26795e-01 0.00000e+00 -2754 5.82832e+00 6.12757e-01 0.00000e+00 -2755 5.85000e+00 3.93782e-01 0.00000e+00 -2756 5.82500e+00 6.96891e-01 0.00000e+00 -2757 5.85000e+00 4.80385e-01 0.00000e+00 -2758 5.80000e+00 9.13397e-01 0.00000e+00 -2759 5.87500e+00 9.06733e-02 0.00000e+00 -2760 5.85000e+00 5.66987e-01 0.00000e+00 -2761 5.82500e+00 7.83494e-01 0.00000e+00 -2762 5.87500e+00 1.77276e-01 0.00000e+00 -2763 5.87500e+00 2.63878e-01 0.00000e+00 -2764 5.87500e+00 3.50481e-01 0.00000e+00 -2765 5.80000e+00 1.00000e+00 0.00000e+00 -2766 5.82500e+00 8.70096e-01 0.00000e+00 -2767 5.87500e+00 4.37083e-01 0.00000e+00 -2768 5.87500e+00 5.23686e-01 0.00000e+00 -2769 5.86148e+00 6.64308e-01 0.00000e+00 -2770 5.90000e+00 0.00000e+00 0.00000e+00 -2771 5.90000e+00 4.73721e-02 0.00000e+00 -2772 5.90000e+00 1.33975e-01 0.00000e+00 -2773 5.82500e+00 9.56699e-01 0.00000e+00 -2774 5.90000e+00 2.20577e-01 0.00000e+00 -2775 5.90000e+00 3.07180e-01 0.00000e+00 -2776 5.85239e+00 8.24227e-01 0.00000e+00 -2777 5.90000e+00 3.93782e-01 0.00000e+00 -2778 5.87010e+00 7.25000e-01 0.00000e+00 -2779 5.88344e+00 6.14383e-01 0.00000e+00 -2780 5.90000e+00 4.80385e-01 0.00000e+00 -2781 5.85000e+00 9.13397e-01 0.00000e+00 -2782 5.87500e+00 7.83494e-01 0.00000e+00 -2783 5.90000e+00 5.66987e-01 0.00000e+00 -2784 5.92917e+00 9.22278e-02 0.00000e+00 -2785 5.85000e+00 1.00000e+00 0.00000e+00 -2786 5.92917e+00 2.61565e-01 0.00000e+00 -2787 5.92500e+00 3.50481e-01 0.00000e+00 -2788 5.93929e+00 1.76626e-01 0.00000e+00 -2789 5.87950e+00 8.67512e-01 0.00000e+00 -2790 5.92917e+00 4.39236e-01 0.00000e+00 -2791 5.91340e+00 6.50000e-01 0.00000e+00 -2792 5.95000e+00 0.00000e+00 0.00000e+00 -2793 5.95000e+00 4.73721e-02 0.00000e+00 -2794 5.95000e+00 1.33975e-01 0.00000e+00 -2795 5.87500e+00 9.56699e-01 0.00000e+00 -2796 5.91340e+00 7.00000e-01 0.00000e+00 -2797 5.95369e+00 2.21754e-01 0.00000e+00 -2798 5.95000e+00 3.07180e-01 0.00000e+00 -2799 5.91340e+00 7.50000e-01 0.00000e+00 -2800 5.95000e+00 3.93782e-01 0.00000e+00 -2801 5.94018e+00 5.24723e-01 0.00000e+00 -2802 5.90985e+00 8.13971e-01 0.00000e+00 -2803 5.90000e+00 9.13397e-01 0.00000e+00 -2804 5.95387e+00 4.78869e-01 0.00000e+00 -2805 5.94216e+00 6.17038e-01 0.00000e+00 -2806 5.95629e+00 5.71617e-01 0.00000e+00 -2807 5.90000e+00 1.00000e+00 0.00000e+00 -2808 5.95670e+00 6.75000e-01 0.00000e+00 -2809 6.00000e+00 0.00000e+00 0.00000e+00 -2810 6.00000e+00 5.00000e-02 0.00000e+00 -2811 5.95670e+00 7.25000e-01 0.00000e+00 -2812 6.00000e+00 1.00000e-01 0.00000e+00 -2813 6.00000e+00 1.50000e-01 0.00000e+00 -2814 6.00000e+00 2.00000e-01 0.00000e+00 -2815 5.94216e+00 8.67413e-01 0.00000e+00 -2816 6.00000e+00 2.50000e-01 0.00000e+00 -2817 5.92917e+00 9.55582e-01 0.00000e+00 -2818 5.95670e+00 7.75000e-01 0.00000e+00 -2819 6.00000e+00 3.00000e-01 0.00000e+00 -2820 6.00000e+00 3.50000e-01 0.00000e+00 -2821 6.00000e+00 4.00000e-01 0.00000e+00 -2822 6.00000e+00 4.50000e-01 0.00000e+00 -2823 5.96174e+00 8.21277e-01 0.00000e+00 -2824 5.95000e+00 9.13397e-01 0.00000e+00 -2825 6.00000e+00 5.00000e-01 0.00000e+00 -2826 6.00000e+00 5.50000e-01 0.00000e+00 -2827 6.00000e+00 6.00000e-01 0.00000e+00 -2828 5.95000e+00 1.00000e+00 0.00000e+00 -2829 6.00000e+00 6.50000e-01 0.00000e+00 -2830 6.00000e+00 7.00000e-01 0.00000e+00 -2831 6.00000e+00 7.50000e-01 0.00000e+00 -2832 6.00000e+00 8.00000e-01 0.00000e+00 -2833 6.00000e+00 8.50000e-01 0.00000e+00 -2834 6.00000e+00 9.00000e-01 0.00000e+00 -2835 6.00000e+00 9.50000e-01 0.00000e+00 -2836 6.00000e+00 1.00000e+00 0.00000e+00 -End Nodes - -Begin Elements CouetteNonNewtonianASGS2D -1 0 60 46 55 -2 0 1157 1166 1140 -3 0 55 46 41 -4 0 41 46 34 -5 0 1 3 2 -6 0 1140 1166 1149 -7 0 1140 1149 1127 -8 0 1127 1149 1133 -9 0 1127 1133 1111 -10 0 1149 1166 1172 -11 0 1149 1172 1158 -12 0 1158 1172 1184 -13 0 1158 1184 1169 -14 0 1133 1149 1158 -15 0 1133 1158 1145 -16 0 1133 1145 1123 -17 0 1123 1147 1125 -18 0 1145 1158 1169 -19 0 1111 1133 1123 -20 0 1111 1123 1097 -21 0 1111 1097 1089 -22 0 1097 1123 1108 -23 0 1108 1123 1125 -24 0 1089 1097 1077 -25 0 1089 1077 1068 -26 0 1077 1097 1087 -27 0 1068 1077 1047 -28 0 1047 1077 1061 -29 0 1111 1089 1105 -30 0 1105 1089 1078 -31 0 1078 1089 1068 -32 0 1087 1097 1108 -33 0 1087 1108 1106 -34 0 1061 1077 1087 -35 0 1061 1087 1071 -36 0 1061 1071 1042 -37 0 1042 1071 1040 -38 0 1071 1087 1106 -39 0 611 592 581 -40 0 581 592 566 -41 0 611 581 602 -42 0 566 592 575 -43 0 566 575 547 -44 0 547 575 555 -45 0 547 555 529 -46 0 529 555 536 -47 0 529 536 508 -48 0 508 536 522 -49 0 508 522 495 -50 0 495 522 503 -51 0 495 503 477 -52 0 477 503 485 -53 0 477 485 459 -54 0 459 485 476 -55 0 459 476 445 -56 0 445 476 458 -57 0 445 458 429 -58 0 429 458 447 -59 0 429 447 417 -60 0 417 447 433 -61 0 417 433 403 -62 0 403 433 423 -63 0 403 423 391 -64 0 391 423 409 -65 0 391 409 377 -66 0 377 409 401 -67 0 377 401 366 -68 0 366 401 393 -69 0 366 393 358 -70 0 358 393 383 -71 0 358 383 350 -72 0 350 383 378 -73 0 350 378 343 -74 0 350 343 316 -75 0 316 343 313 -76 0 343 378 373 -77 0 343 373 340 -78 0 340 373 371 -79 0 313 343 340 -80 0 313 340 310 -81 0 313 310 283 -82 0 283 301 268 -83 0 310 340 335 -84 0 602 581 578 -85 0 602 578 597 -86 0 602 597 622 -87 0 622 597 619 -88 0 619 597 595 -89 0 595 597 573 -90 0 573 597 578 -91 0 573 578 552 -92 0 552 578 556 -93 0 573 552 549 -94 0 556 578 581 -95 0 556 581 566 -96 0 549 552 526 -97 0 526 552 530 -98 0 526 530 504 -99 0 504 530 510 -100 0 510 530 540 -101 0 540 530 556 -102 0 556 530 552 -103 0 556 566 540 -104 0 540 566 547 -105 0 540 547 520 -106 0 540 520 510 -107 0 520 547 529 -108 0 510 520 492 -109 0 510 492 483 -110 0 483 492 464 -111 0 464 492 474 -112 0 483 464 457 -113 0 474 492 502 -114 0 457 464 436 -115 0 502 492 520 -116 0 502 520 529 -117 0 502 529 508 -118 0 502 508 481 -119 0 481 508 495 -120 0 481 495 465 -121 0 465 495 477 -122 0 481 465 456 -123 0 481 456 474 -124 0 474 456 446 -125 0 446 456 427 -126 0 427 456 435 -127 0 435 456 465 -128 0 435 465 449 -129 0 435 449 419 -130 0 419 449 430 -131 0 449 465 477 -132 0 430 449 459 -133 0 436 464 446 -134 0 446 464 474 -135 0 459 449 477 -136 0 430 459 445 -137 0 430 445 414 -138 0 414 445 429 -139 0 414 429 398 -140 0 398 429 417 -141 0 398 417 380 -142 0 380 417 403 -143 0 380 403 367 -144 0 367 403 391 -145 0 367 391 355 -146 0 355 391 377 -147 0 430 414 400 -148 0 400 414 379 -149 0 379 414 398 -150 0 379 398 363 -151 0 363 398 380 -152 0 430 400 419 -153 0 419 400 385 -154 0 385 400 364 -155 0 385 364 349 -156 0 349 364 331 -157 0 331 364 344 -158 0 344 364 379 -159 0 364 400 379 -160 0 419 385 405 -161 0 419 405 435 -162 0 405 385 372 -163 0 372 385 349 -164 0 435 405 427 -165 0 427 405 396 -166 0 396 405 372 -167 0 427 396 416 -168 0 416 396 381 -169 0 381 396 359 -170 0 359 396 372 -171 0 359 372 338 -172 0 359 338 325 -173 0 325 338 304 -174 0 304 338 315 -175 0 315 338 349 -176 0 359 325 347 -177 0 347 325 314 -178 0 314 325 289 -179 0 289 325 304 -180 0 338 372 349 -181 0 549 526 524 -182 0 524 526 499 -183 0 499 526 504 -184 0 499 504 478 -185 0 478 504 483 -186 0 549 524 544 -187 0 524 499 498 -188 0 498 499 475 -189 0 475 499 478 -190 0 475 478 452 -191 0 452 478 457 -192 0 544 524 518 -193 0 518 524 498 -194 0 483 504 510 -195 0 457 478 483 -196 0 549 544 570 -197 0 570 544 565 -198 0 549 570 573 -199 0 565 544 541 -200 0 541 544 518 -201 0 570 565 590 -202 0 590 565 586 -203 0 570 590 595 -204 0 595 590 614 -205 0 586 565 563 -206 0 614 590 612 -207 0 612 590 586 -208 0 563 565 541 -209 0 563 541 537 -210 0 537 541 515 -211 0 515 541 518 -212 0 515 518 491 -213 0 491 518 498 -214 0 612 586 609 -215 0 612 609 634 -216 0 634 609 631 -217 0 609 586 584 -218 0 584 586 563 -219 0 573 570 595 -220 0 631 609 606 -221 0 631 606 629 -222 0 629 606 605 -223 0 605 606 582 -224 0 582 606 584 -225 0 584 606 609 -226 0 629 605 630 -227 0 629 630 651 -228 0 651 630 653 -229 0 651 653 675 -230 0 653 630 632 -231 0 632 630 607 -232 0 607 630 605 -233 0 607 605 583 -234 0 583 605 582 -235 0 583 582 557 -236 0 557 582 559 -237 0 559 582 584 -238 0 559 584 563 -239 0 559 563 537 -240 0 559 537 534 -241 0 534 537 512 -242 0 559 534 557 -243 0 557 534 535 -244 0 557 535 560 -245 0 560 535 539 -246 0 512 537 515 -247 0 675 653 678 -248 0 539 535 513 -249 0 513 535 511 -250 0 511 535 534 -251 0 678 653 655 -252 0 678 655 680 -253 0 680 655 659 -254 0 659 655 635 -255 0 635 655 632 -256 0 632 655 653 -257 0 512 515 488 -258 0 512 488 486 -259 0 512 486 511 -260 0 511 486 487 -261 0 486 488 463 -262 0 487 486 461 -263 0 461 486 463 -264 0 463 488 467 -265 0 463 467 440 -266 0 440 467 442 -267 0 467 488 491 -268 0 442 467 470 -269 0 470 467 491 -270 0 442 470 448 -271 0 442 448 420 -272 0 448 470 475 -273 0 420 448 424 -274 0 424 448 452 -275 0 488 515 491 -276 0 475 470 498 -277 0 498 470 491 -278 0 452 448 475 -279 0 595 614 619 -280 0 619 614 639 -281 0 619 639 643 -282 0 639 614 637 -283 0 637 614 612 -284 0 637 612 634 -285 0 637 634 658 -286 0 658 634 654 -287 0 654 634 631 -288 0 654 631 652 -289 0 652 631 629 -290 0 643 639 664 -291 0 664 639 661 -292 0 619 643 622 -293 0 622 643 647 -294 0 661 639 637 -295 0 661 637 658 -296 0 661 658 681 -297 0 681 658 679 -298 0 679 658 654 -299 0 647 643 667 -300 0 652 629 651 -301 0 652 651 673 -302 0 673 651 675 -303 0 673 675 695 -304 0 695 675 697 -305 0 695 697 719 -306 0 719 697 721 -307 0 697 675 678 -308 0 721 697 699 -309 0 699 697 678 -310 0 699 678 680 -311 0 667 643 664 -312 0 667 664 689 -313 0 689 664 685 -314 0 685 664 661 -315 0 685 661 681 -316 0 685 681 704 -317 0 704 681 701 -318 0 685 704 708 -319 0 708 704 729 -320 0 729 704 725 -321 0 729 725 748 -322 0 748 725 745 -323 0 748 745 770 -324 0 701 681 679 -325 0 770 745 766 -326 0 766 745 743 -327 0 743 745 722 -328 0 722 745 725 -329 0 770 766 791 -330 0 791 766 788 -331 0 791 788 812 -332 0 812 788 807 -333 0 812 807 828 -334 0 828 807 826 -335 0 828 826 849 -336 0 849 826 846 -337 0 846 826 825 -338 0 825 826 804 -339 0 804 826 807 -340 0 722 725 701 -341 0 722 701 698 -342 0 698 701 679 -343 0 698 679 677 -344 0 677 679 654 -345 0 677 654 652 -346 0 677 652 673 -347 0 701 725 704 -348 0 677 673 696 -349 0 696 673 695 -350 0 677 696 698 -351 0 698 696 720 -352 0 720 696 718 -353 0 718 696 695 -354 0 718 695 719 -355 0 718 719 738 -356 0 718 738 739 -357 0 739 738 762 -358 0 762 738 763 -359 0 763 738 740 -360 0 740 738 719 -361 0 740 719 721 -362 0 740 721 744 -363 0 744 721 724 -364 0 724 721 699 -365 0 744 724 747 -366 0 744 747 767 -367 0 747 724 727 -368 0 727 724 703 -369 0 727 703 705 -370 0 705 703 683 -371 0 683 703 680 -372 0 703 724 699 -373 0 767 747 771 -374 0 771 747 750 -375 0 750 747 727 -376 0 703 699 680 -377 0 720 718 739 -378 0 720 739 743 -379 0 743 739 764 -380 0 720 743 722 -381 0 720 722 698 -382 0 764 739 762 -383 0 764 762 786 -384 0 743 764 766 -385 0 766 764 788 -386 0 788 764 786 -387 0 788 786 807 -388 0 807 786 804 -389 0 786 762 785 -390 0 785 762 763 -391 0 786 785 804 -392 0 804 785 805 -393 0 805 785 787 -394 0 804 805 825 -395 0 805 787 809 -396 0 787 785 763 -397 0 787 763 765 -398 0 765 763 740 -399 0 765 740 744 -400 0 809 787 790 -401 0 809 790 813 -402 0 813 790 792 -403 0 790 787 765 -404 0 790 765 767 -405 0 767 765 744 -406 0 792 790 767 -407 0 792 767 771 -408 0 792 771 794 -409 0 794 771 773 -410 0 794 773 796 -411 0 773 771 750 -412 0 773 750 754 -413 0 754 750 730 -414 0 796 773 777 -415 0 730 750 727 -416 0 777 773 754 -417 0 777 754 756 -418 0 756 754 733 -419 0 733 754 730 -420 0 756 733 737 -421 0 737 733 713 -422 0 713 733 710 -423 0 710 733 730 -424 0 710 730 705 -425 0 710 705 687 -426 0 705 730 727 -427 0 687 705 683 -428 0 687 683 663 -429 0 663 683 659 -430 0 825 805 827 -431 0 827 805 809 -432 0 825 827 847 -433 0 847 827 851 -434 0 851 827 829 -435 0 829 827 809 -436 0 829 809 813 -437 0 829 813 830 -438 0 830 813 815 -439 0 830 815 836 -440 0 836 815 816 -441 0 836 816 838 -442 0 838 816 820 -443 0 816 815 794 -444 0 794 815 792 -445 0 820 816 796 -446 0 796 816 794 -447 0 815 813 792 -448 0 659 683 680 -449 0 756 737 760 -450 0 756 760 779 -451 0 760 737 742 -452 0 779 760 784 -453 0 756 779 777 -454 0 784 760 768 -455 0 742 737 716 -456 0 768 760 742 -457 0 768 742 751 -458 0 716 737 713 -459 0 716 713 692 -460 0 692 713 690 -461 0 692 690 670 -462 0 690 713 710 -463 0 670 690 665 -464 0 751 742 726 -465 0 726 742 716 -466 0 670 665 645 -467 0 645 665 640 -468 0 665 690 687 -469 0 687 690 710 -470 0 670 645 648 -471 0 648 645 625 -472 0 625 645 621 -473 0 625 621 600 -474 0 621 645 640 -475 0 600 621 596 -476 0 621 640 616 -477 0 616 640 638 -478 0 638 640 663 -479 0 663 640 665 -480 0 663 665 687 -481 0 596 621 616 -482 0 596 616 591 -483 0 591 616 613 -484 0 596 591 571 -485 0 571 591 568 -486 0 613 616 638 -487 0 613 638 635 -488 0 635 638 659 -489 0 659 638 663 -490 0 568 591 587 -491 0 587 591 613 -492 0 587 613 610 -493 0 610 613 635 -494 0 610 635 632 -495 0 610 632 607 -496 0 568 587 564 -497 0 564 587 585 -498 0 585 587 610 -499 0 585 610 607 -500 0 585 607 583 -501 0 568 564 543 -502 0 543 564 539 -503 0 585 583 560 -504 0 560 583 557 -505 0 777 779 800 -506 0 777 800 796 -507 0 796 800 820 -508 0 800 779 803 -509 0 803 779 784 -510 0 803 784 811 -511 0 811 784 793 -512 0 811 793 817 -513 0 817 793 798 -514 0 798 793 775 -515 0 775 793 768 -516 0 798 775 780 -517 0 780 775 755 -518 0 755 775 751 -519 0 793 784 768 -520 0 751 775 768 -521 0 539 564 560 -522 0 560 564 585 -523 0 707 732 717 -524 0 717 732 746 -525 0 746 732 757 -526 0 707 717 693 -527 0 693 717 709 -528 0 707 693 682 -529 0 682 693 669 -530 0 709 717 734 -531 0 709 734 723 -532 0 723 734 749 -533 0 749 734 758 -534 0 758 734 746 -535 0 758 746 772 -536 0 772 746 757 -537 0 772 757 781 -538 0 772 781 797 -539 0 797 781 806 -540 0 734 717 746 -541 0 669 693 684 -542 0 684 693 709 -543 0 684 709 694 -544 0 684 694 671 -545 0 671 694 688 -546 0 688 694 712 -547 0 688 712 702 -548 0 702 712 728 -549 0 728 712 736 -550 0 736 712 723 -551 0 712 694 723 -552 0 694 709 723 -553 0 669 684 657 -554 0 657 684 671 -555 0 657 671 646 -556 0 646 671 662 -557 0 662 671 688 -558 0 657 646 628 -559 0 657 628 642 -560 0 642 628 617 -561 0 642 617 627 -562 0 617 628 603 -563 0 603 628 620 -564 0 620 628 646 -565 0 620 646 636 -566 0 636 646 662 -567 0 620 636 608 -568 0 669 657 642 -569 0 669 642 656 -570 0 620 608 594 -571 0 627 617 601 -572 0 601 617 589 -573 0 589 617 603 -574 0 589 603 577 -575 0 577 603 594 -576 0 594 603 620 -577 0 594 608 580 -578 0 594 580 567 -579 0 567 580 554 -580 0 608 636 623 -581 0 623 636 650 -582 0 650 636 662 -583 0 580 608 598 -584 0 580 598 572 -585 0 572 598 588 -586 0 598 608 623 -587 0 588 598 615 -588 0 615 598 623 -589 0 554 580 572 -590 0 656 642 627 -591 0 554 572 546 -592 0 546 572 561 -593 0 561 572 588 -594 0 554 546 528 -595 0 546 561 533 -596 0 528 546 517 -597 0 554 528 538 -598 0 538 528 509 -599 0 509 528 500 -600 0 500 528 517 -601 0 533 561 553 -602 0 533 553 527 -603 0 527 553 548 -604 0 548 553 574 -605 0 574 553 579 -606 0 579 553 561 -607 0 579 561 588 -608 0 579 588 604 -609 0 579 604 599 -610 0 604 588 615 -611 0 604 615 633 -612 0 633 615 641 -613 0 641 615 623 -614 0 641 623 650 -615 0 599 604 624 -616 0 624 604 633 -617 0 624 633 649 -618 0 624 649 644 -619 0 649 633 660 -620 0 644 649 668 -621 0 668 649 674 -622 0 674 649 660 -623 0 674 660 686 -624 0 686 660 666 -625 0 666 660 641 -626 0 641 660 633 -627 0 517 546 533 -628 0 517 533 506 -629 0 517 506 489 -630 0 506 533 527 -631 0 517 489 500 -632 0 500 489 472 -633 0 472 489 460 -634 0 460 489 480 -635 0 489 506 480 -636 0 480 506 501 -637 0 501 506 527 -638 0 501 527 521 -639 0 480 501 473 -640 0 521 527 548 -641 0 521 548 542 -642 0 542 548 569 -643 0 473 501 496 -644 0 472 460 443 -645 0 443 460 432 -646 0 432 460 453 -647 0 453 460 480 -648 0 496 501 521 -649 0 569 548 574 -650 0 569 574 593 -651 0 593 574 599 -652 0 496 521 514 -653 0 496 514 484 -654 0 484 514 507 -655 0 507 514 531 -656 0 531 514 542 -657 0 542 514 521 -658 0 599 574 579 -659 0 641 650 666 -660 0 666 650 676 -661 0 666 676 691 -662 0 691 676 702 -663 0 702 676 688 -664 0 688 676 662 -665 0 691 702 715 -666 0 715 702 728 -667 0 715 728 741 -668 0 741 728 753 -669 0 715 741 735 -670 0 735 741 759 -671 0 735 759 752 -672 0 752 759 776 -673 0 759 741 769 -674 0 769 741 753 -675 0 769 753 778 -676 0 769 778 795 -677 0 778 753 761 -678 0 795 778 802 -679 0 802 778 789 -680 0 789 778 761 -681 0 776 759 782 -682 0 761 753 736 -683 0 736 753 728 -684 0 789 761 774 -685 0 789 774 799 -686 0 799 774 783 -687 0 783 774 758 -688 0 758 774 749 -689 0 749 774 761 -690 0 749 761 736 -691 0 799 783 810 -692 0 810 783 797 -693 0 797 783 772 -694 0 772 783 758 -695 0 799 810 822 -696 0 822 810 835 -697 0 822 835 844 -698 0 844 835 857 -699 0 782 759 769 -700 0 835 810 821 -701 0 821 810 797 -702 0 821 797 806 -703 0 821 806 832 -704 0 821 832 843 -705 0 843 832 856 -706 0 835 821 843 -707 0 835 843 857 -708 0 857 843 866 -709 0 866 843 856 -710 0 866 856 879 -711 0 866 879 893 -712 0 857 866 880 -713 0 893 879 904 -714 0 866 893 880 -715 0 880 893 906 -716 0 880 906 894 -717 0 906 893 917 -718 0 880 894 869 -719 0 894 906 918 -720 0 917 893 904 -721 0 917 904 929 -722 0 869 894 884 -723 0 918 906 930 -724 0 884 894 909 -725 0 930 906 917 -726 0 909 894 918 -727 0 749 736 723 -728 0 909 918 933 -729 0 909 933 922 -730 0 909 922 898 -731 0 898 922 914 -732 0 922 933 947 -733 0 947 933 958 -734 0 958 933 944 -735 0 944 933 918 -736 0 944 918 930 -737 0 914 922 939 -738 0 939 922 947 -739 0 944 930 956 -740 0 956 930 941 -741 0 956 941 965 -742 0 939 947 962 -743 0 962 947 972 -744 0 941 930 917 -745 0 965 941 954 -746 0 972 947 958 -747 0 972 958 983 -748 0 983 958 970 -749 0 970 958 944 -750 0 970 944 956 -751 0 970 956 981 -752 0 981 956 965 -753 0 981 965 991 -754 0 991 965 980 -755 0 917 929 941 -756 0 954 941 929 -757 0 980 965 954 -758 0 542 569 558 -759 0 542 558 531 -760 0 531 558 571 -761 0 571 558 596 -762 0 558 569 600 -763 0 909 898 884 -764 0 884 898 875 -765 0 884 875 858 -766 0 858 875 850 -767 0 875 898 887 -768 0 875 887 863 -769 0 887 898 914 -770 0 884 858 869 -771 0 850 875 863 -772 0 863 887 878 -773 0 863 878 854 -774 0 854 878 872 -775 0 872 878 895 -776 0 895 878 903 -777 0 903 878 887 -778 0 903 887 914 -779 0 903 914 928 -780 0 928 914 939 -781 0 903 928 919 -782 0 919 928 943 -783 0 919 943 937 -784 0 937 943 960 -785 0 960 943 967 -786 0 967 943 952 -787 0 952 943 928 -788 0 952 928 939 -789 0 869 858 844 -790 0 844 858 837 -791 0 869 844 857 -792 0 837 858 850 -793 0 837 850 824 -794 0 844 837 822 -795 0 822 837 814 -796 0 814 837 824 -797 0 814 824 802 -798 0 802 824 819 -799 0 819 824 841 -800 0 824 850 841 -801 0 841 850 863 -802 0 841 863 854 -803 0 952 939 962 -804 0 814 802 789 -805 0 814 789 799 -806 0 814 799 822 -807 0 952 962 977 -808 0 977 962 987 -809 0 987 962 972 -810 0 977 987 1002 -811 0 977 1002 993 -812 0 1002 987 1012 -813 0 993 1002 1018 -814 0 1018 1002 1026 -815 0 1026 1002 1012 -816 0 1026 1012 1035 -817 0 1035 1012 1022 -818 0 1022 1012 998 -819 0 998 1012 987 -820 0 1022 998 1007 -821 0 1022 1007 1031 -822 0 1031 1007 1019 -823 0 1019 1007 994 -824 0 994 1007 983 -825 0 1007 998 983 -826 0 998 987 972 -827 0 952 977 967 -828 0 998 972 983 -829 0 967 977 993 -830 0 967 993 984 -831 0 967 984 960 -832 0 984 993 1008 -833 0 984 1008 1001 -834 0 1001 1008 1025 -835 0 1001 1025 1017 -836 0 1017 1025 1038 -837 0 1025 1008 1033 -838 0 1033 1008 1018 -839 0 1018 1008 993 -840 0 1033 1018 1041 -841 0 1033 1041 1057 -842 0 1057 1041 1063 -843 0 1063 1041 1051 -844 0 1051 1041 1026 -845 0 1026 1041 1018 -846 0 1057 1063 1082 -847 0 1057 1082 1070 -848 0 1082 1063 1086 -849 0 1086 1063 1073 -850 0 1073 1063 1051 -851 0 1038 1025 1048 -852 0 1048 1025 1033 -853 0 1048 1033 1057 -854 0 1070 1082 1092 -855 0 1070 1092 1090 -856 0 1090 1114 1121 -857 0 1092 1082 1112 -858 0 1073 1051 1059 -859 0 1073 1059 1083 -860 0 1083 1059 1069 -861 0 1069 1059 1046 -862 0 1046 1059 1035 -863 0 1035 1059 1051 -864 0 1035 1051 1026 -865 0 1073 1083 1107 -866 0 960 984 975 -867 0 975 984 1001 -868 0 960 975 951 -869 0 960 951 937 -870 0 951 975 969 -871 0 951 969 945 -872 0 945 969 961 -873 0 961 969 985 -874 0 985 969 992 -875 0 992 969 975 -876 0 992 975 1001 -877 0 992 1001 1017 -878 0 937 951 926 -879 0 926 951 945 -880 0 937 926 910 -881 0 937 910 919 -882 0 910 926 902 -883 0 910 902 886 -884 0 886 902 877 -885 0 877 902 896 -886 0 896 902 921 -887 0 896 921 915 -888 0 915 921 938 -889 0 938 921 945 -890 0 945 921 926 -891 0 926 921 902 -892 0 919 910 895 -893 0 919 895 903 -894 0 992 1017 1010 -895 0 1010 1017 1034 -896 0 1034 1017 1038 -897 0 992 1010 985 -898 0 1034 1038 1058 -899 0 1058 1038 1062 -900 0 1062 1038 1048 -901 0 1062 1048 1070 -902 0 1070 1048 1057 -903 0 985 1010 1003 -904 0 1003 1010 1027 -905 0 1003 1027 1020 -906 0 1027 1010 1034 -907 0 1020 1027 1045 -908 0 1045 1027 1050 -909 0 1050 1027 1034 -910 0 1045 1050 1066 -911 0 1066 1050 1072 -912 0 1045 1066 1060 -913 0 1060 1066 1084 -914 0 1084 1066 1088 -915 0 1072 1050 1058 -916 0 1088 1066 1072 -917 0 1050 1034 1058 -918 0 1088 1072 1093 -919 0 1088 1093 1110 -920 0 1110 1093 1126 -921 0 1093 1072 1080 -922 0 1080 1072 1058 -923 0 1080 1058 1062 -924 0 1093 1080 1102 -925 0 1102 1080 1090 -926 0 1093 1102 1126 -927 0 1080 1062 1090 -928 0 1090 1062 1070 -929 0 1020 1045 1036 -930 0 1020 1036 1013 -931 0 1036 1045 1060 -932 0 1013 1036 1032 -933 0 1013 1032 1009 -934 0 1009 1032 1028 -935 0 1032 1036 1055 -936 0 1055 1036 1060 -937 0 1028 1032 1052 -938 0 1028 1052 1049 -939 0 1049 1052 1078 -940 0 1052 1032 1055 -941 0 1052 1055 1074 -942 0 1074 1055 1079 -943 0 1074 1079 1091 -944 0 1079 1055 1060 -945 0 1091 1079 1098 -946 0 1091 1098 1113 -947 0 1113 1098 1119 -948 0 1098 1079 1084 -949 0 1119 1098 1104 -950 0 1104 1098 1084 -951 0 1104 1084 1088 -952 0 1079 1060 1084 -953 0 1104 1088 1110 -954 0 1104 1110 1134 -955 0 1020 1013 997 -956 0 997 1013 990 -957 0 1020 997 1003 -958 0 1003 997 979 -959 0 979 997 973 -960 0 979 973 955 -961 0 973 997 990 -962 0 955 973 949 -963 0 955 949 932 -964 0 932 949 924 -965 0 990 1013 1009 -966 0 949 973 966 -967 0 949 966 942 -968 0 942 966 963 -969 0 963 966 986 -970 0 986 966 990 -971 0 990 966 973 -972 0 924 949 942 -973 0 924 942 920 -974 0 920 942 940 -975 0 924 920 900 -976 0 940 942 963 -977 0 940 963 959 -978 0 959 963 982 -979 0 982 963 986 -980 0 959 982 976 -981 0 976 982 1000 -982 0 959 976 953 -983 0 953 976 974 -984 0 974 976 996 -985 0 996 976 1000 -986 0 900 920 897 -987 0 900 897 876 -988 0 1000 982 1005 -989 0 897 920 916 -990 0 916 920 940 -991 0 1005 982 986 -992 0 1005 986 1009 -993 0 1005 1009 1028 -994 0 1005 1028 1024 -995 0 1024 1028 1049 -996 0 876 897 874 -997 0 876 874 853 -998 0 853 874 852 -999 0 874 897 892 -1000 0 892 897 916 -1001 0 852 874 867 -1002 0 867 874 892 -1003 0 892 916 911 -1004 0 911 916 936 -1005 0 936 916 940 -1006 0 867 892 888 -1007 0 867 888 864 -1008 0 888 892 911 -1009 0 888 911 908 -1010 0 908 911 931 -1011 0 931 911 936 -1012 0 864 888 885 -1013 0 885 888 908 -1014 0 864 885 862 -1015 0 864 862 836 -1016 0 862 885 882 -1017 0 882 885 905 -1018 0 862 882 860 -1019 0 860 882 881 -1020 0 905 885 908 -1021 0 905 908 927 -1022 0 927 908 931 -1023 0 927 931 950 -1024 0 950 931 953 -1025 0 953 931 936 -1026 0 881 882 901 -1027 0 881 901 899 -1028 0 899 901 923 -1029 0 923 901 925 -1030 0 925 901 905 -1031 0 901 882 905 -1032 0 1009 986 990 -1033 0 936 940 959 -1034 0 936 959 953 -1035 0 895 910 886 -1036 0 895 886 872 -1037 0 872 886 861 -1038 0 861 886 877 -1039 0 872 861 845 -1040 0 845 861 840 -1041 0 840 861 855 -1042 0 845 840 823 -1043 0 855 861 877 -1044 0 823 840 818 -1045 0 823 818 801 -1046 0 801 818 780 -1047 0 845 823 831 -1048 0 845 831 854 -1049 0 854 831 841 -1050 0 831 823 808 -1051 0 808 823 801 -1052 0 818 840 833 -1053 0 833 840 855 -1054 0 833 855 848 -1055 0 848 855 873 -1056 0 873 855 877 -1057 0 873 877 896 -1058 0 818 833 798 -1059 0 873 896 889 -1060 0 873 889 865 -1061 0 873 865 848 -1062 0 848 865 842 -1063 0 848 842 817 -1064 0 865 889 883 -1065 0 865 883 859 -1066 0 859 883 876 -1067 0 876 883 900 -1068 0 883 889 907 -1069 0 883 907 900 -1070 0 900 907 924 -1071 0 889 896 915 -1072 0 924 907 932 -1073 0 932 907 915 -1074 0 932 915 938 -1075 0 932 938 955 -1076 0 955 938 961 -1077 0 955 961 979 -1078 0 979 961 985 -1079 0 979 985 1003 -1080 0 961 938 945 -1081 0 915 907 889 -1082 0 841 831 819 -1083 0 819 831 808 -1084 0 819 808 795 -1085 0 795 808 782 -1086 0 782 808 801 -1087 0 782 801 776 -1088 0 776 801 780 -1089 0 776 780 755 -1090 0 819 795 802 -1091 0 925 905 927 -1092 0 925 927 948 -1093 0 925 948 946 -1094 0 946 948 968 -1095 0 946 968 964 -1096 0 948 927 950 -1097 0 948 950 971 -1098 0 971 950 974 -1099 0 974 950 953 -1100 0 968 948 971 -1101 0 968 971 989 -1102 0 989 971 995 -1103 0 968 989 988 -1104 0 988 989 1011 -1105 0 988 1011 999 -1106 0 988 999 978 -1107 0 1011 989 1014 -1108 0 1014 989 995 -1109 0 964 968 988 -1110 0 964 988 978 -1111 0 964 978 957 -1112 0 1014 995 1015 -1113 0 1015 995 996 -1114 0 996 995 974 -1115 0 974 995 971 -1116 0 1014 1015 1042 -1117 0 1015 996 1021 -1118 0 1015 1021 1037 -1119 0 1021 996 1000 -1120 0 1021 1000 1024 -1121 0 1024 1000 1005 -1122 0 1015 1037 1042 -1123 0 1037 1021 1047 -1124 0 1037 1047 1061 -1125 0 1021 1024 1047 -1126 0 344 379 363 -1127 0 344 363 328 -1128 0 328 363 346 -1129 0 346 363 380 -1130 0 344 328 311 -1131 0 311 328 293 -1132 0 293 328 312 -1133 0 312 328 346 -1134 0 312 346 333 -1135 0 333 346 367 -1136 0 333 367 355 -1137 0 333 355 319 -1138 0 367 346 380 -1139 0 319 355 341 -1140 0 341 355 377 -1141 0 341 377 366 -1142 0 341 366 332 -1143 0 341 332 308 -1144 0 332 366 358 -1145 0 332 358 323 -1146 0 323 358 350 -1147 0 323 350 316 -1148 0 319 341 308 -1149 0 319 308 287 -1150 0 287 308 277 -1151 0 308 332 300 -1152 0 300 332 323 -1153 0 300 323 290 -1154 0 290 323 316 -1155 0 290 316 286 -1156 0 290 286 260 -1157 0 286 316 313 -1158 0 290 260 271 -1159 0 271 260 238 -1160 0 290 271 300 -1161 0 300 271 277 -1162 0 300 277 308 -1163 0 238 260 232 -1164 0 232 260 258 -1165 0 258 260 286 -1166 0 232 258 229 -1167 0 232 229 207 -1168 0 229 258 255 -1169 0 255 258 283 -1170 0 207 229 204 -1171 0 204 229 236 -1172 0 344 311 331 -1173 0 283 258 286 -1174 0 283 286 313 -1175 0 331 311 296 -1176 0 296 311 279 -1177 0 279 311 293 -1178 0 296 279 262 -1179 0 262 279 249 -1180 0 249 279 261 -1181 0 261 279 293 -1182 0 261 293 280 -1183 0 261 280 251 -1184 0 251 280 266 -1185 0 266 280 299 -1186 0 251 266 235 -1187 0 235 266 257 -1188 0 257 266 287 -1189 0 287 266 299 -1190 0 299 280 312 -1191 0 280 293 312 -1192 0 299 312 333 -1193 0 299 333 319 -1194 0 299 319 287 -1195 0 238 232 212 -1196 0 212 232 207 -1197 0 212 207 187 -1198 0 238 212 220 -1199 0 220 212 192 -1200 0 187 207 184 -1201 0 192 212 187 -1202 0 192 187 167 -1203 0 184 207 204 -1204 0 167 187 163 -1205 0 167 163 145 -1206 0 184 204 182 -1207 0 163 187 184 -1208 0 163 184 161 -1209 0 145 163 141 -1210 0 141 163 161 -1211 0 145 141 124 -1212 0 124 141 122 -1213 0 122 141 135 -1214 0 145 124 127 -1215 0 145 127 151 -1216 0 151 127 137 -1217 0 137 127 117 -1218 0 117 127 107 -1219 0 107 127 124 -1220 0 107 124 105 -1221 0 105 124 122 -1222 0 107 105 89 -1223 0 89 105 87 -1224 0 87 105 92 -1225 0 107 89 97 -1226 0 107 97 117 -1227 0 117 97 103 -1228 0 103 97 85 -1229 0 85 97 78 -1230 0 78 97 89 -1231 0 78 89 72 -1232 0 72 89 87 -1233 0 72 87 75 -1234 0 78 72 63 -1235 0 63 72 55 -1236 0 78 63 68 -1237 0 78 68 85 -1238 0 85 68 73 -1239 0 85 73 90 -1240 0 68 63 51 -1241 0 90 73 83 -1242 0 51 63 49 -1243 0 49 63 55 -1244 0 49 55 41 -1245 0 49 41 37 -1246 0 49 37 51 -1247 0 37 41 29 -1248 0 29 41 34 -1249 0 37 29 27 -1250 0 27 29 23 -1251 0 37 27 39 -1252 0 27 23 19 -1253 0 23 29 25 -1254 0 37 39 51 -1255 0 39 27 28 -1256 0 19 23 16 -1257 0 16 23 17 -1258 0 161 184 182 -1259 0 83 73 66 -1260 0 66 73 58 -1261 0 83 66 74 -1262 0 58 73 68 -1263 0 66 58 50 -1264 0 50 58 39 -1265 0 66 50 59 -1266 0 66 59 74 -1267 0 74 59 70 -1268 0 74 70 86 -1269 0 70 59 56 -1270 0 56 59 45 -1271 0 86 70 82 -1272 0 82 70 67 -1273 0 67 70 56 -1274 0 67 56 53 -1275 0 53 56 43 -1276 0 45 59 50 -1277 0 43 56 45 -1278 0 43 45 33 -1279 0 33 45 38 -1280 0 38 45 50 -1281 0 38 50 39 -1282 0 38 39 28 -1283 0 38 28 33 -1284 0 296 262 281 -1285 0 281 262 252 -1286 0 296 281 315 -1287 0 315 281 304 -1288 0 252 262 233 -1289 0 233 262 249 -1290 0 233 249 219 -1291 0 219 249 231 -1292 0 231 249 261 -1293 0 296 315 331 -1294 0 331 315 349 -1295 0 304 281 272 -1296 0 272 281 252 -1297 0 272 252 242 -1298 0 242 252 224 -1299 0 224 252 233 -1300 0 304 272 289 -1301 0 289 272 259 -1302 0 259 272 242 -1303 0 289 259 282 -1304 0 282 259 253 -1305 0 253 259 230 -1306 0 230 259 242 -1307 0 230 242 213 -1308 0 230 213 203 -1309 0 203 213 186 -1310 0 203 186 178 -1311 0 178 186 162 -1312 0 186 213 196 -1313 0 196 213 224 -1314 0 162 186 170 -1315 0 170 186 196 -1316 0 170 196 179 -1317 0 179 196 205 -1318 0 205 196 224 -1319 0 205 224 233 -1320 0 213 242 224 -1321 0 205 233 219 -1322 0 205 219 189 -1323 0 205 189 179 -1324 0 189 219 202 -1325 0 202 219 231 -1326 0 202 231 222 -1327 0 222 231 251 -1328 0 251 231 261 -1329 0 189 202 177 -1330 0 177 202 194 -1331 0 194 202 222 -1332 0 194 222 208 -1333 0 208 222 235 -1334 0 235 222 251 -1335 0 194 208 181 -1336 0 181 208 200 -1337 0 200 208 227 -1338 0 227 208 235 -1339 0 227 235 257 -1340 0 227 257 247 -1341 0 247 257 277 -1342 0 277 257 287 -1343 0 181 200 175 -1344 0 181 175 160 -1345 0 175 200 192 -1346 0 192 200 220 -1347 0 220 200 227 -1348 0 160 175 151 -1349 0 160 151 137 -1350 0 160 137 144 -1351 0 144 137 123 -1352 0 123 137 117 -1353 0 151 175 167 -1354 0 167 175 192 -1355 0 151 167 145 -1356 0 179 189 165 -1357 0 165 189 177 -1358 0 179 165 155 -1359 0 155 165 143 -1360 0 143 165 154 -1361 0 154 165 177 -1362 0 179 155 170 -1363 0 154 177 166 -1364 0 166 177 194 -1365 0 170 155 146 -1366 0 170 146 162 -1367 0 146 155 133 -1368 0 146 133 125 -1369 0 125 133 110 -1370 0 125 110 104 -1371 0 104 110 91 -1372 0 91 110 101 -1373 0 101 110 121 -1374 0 121 110 133 -1375 0 121 133 143 -1376 0 121 143 131 -1377 0 131 143 154 -1378 0 143 133 155 -1379 0 162 146 140 -1380 0 140 146 125 -1381 0 131 154 144 -1382 0 144 154 166 -1383 0 144 166 160 -1384 0 160 166 181 -1385 0 181 166 194 -1386 0 131 144 123 -1387 0 131 123 108 -1388 0 108 123 103 -1389 0 131 108 121 -1390 0 121 108 101 -1391 0 101 108 90 -1392 0 101 90 83 -1393 0 101 83 91 -1394 0 91 83 74 -1395 0 91 74 86 -1396 0 90 108 103 -1397 0 91 86 104 -1398 0 104 86 100 -1399 0 100 86 82 -1400 0 104 100 119 -1401 0 119 100 115 -1402 0 100 82 98 -1403 0 115 100 98 -1404 0 98 82 80 -1405 0 80 82 67 -1406 0 80 67 64 -1407 0 64 67 53 -1408 0 64 53 52 -1409 0 52 53 40 -1410 0 40 53 43 -1411 0 115 98 111 -1412 0 115 111 130 -1413 0 130 111 128 -1414 0 128 111 109 -1415 0 109 111 94 -1416 0 94 111 98 -1417 0 94 98 80 -1418 0 94 80 79 -1419 0 79 80 64 -1420 0 103 123 117 -1421 0 79 64 65 -1422 0 65 64 52 -1423 0 79 65 81 -1424 0 81 65 69 -1425 0 69 65 54 -1426 0 54 65 52 -1427 0 79 81 95 -1428 0 79 95 94 -1429 0 95 81 99 -1430 0 95 99 112 -1431 0 112 99 118 -1432 0 118 99 102 -1433 0 102 99 84 -1434 0 84 99 81 -1435 0 54 52 42 -1436 0 42 52 40 -1437 0 54 42 44 -1438 0 44 42 32 -1439 0 32 42 30 -1440 0 30 42 40 -1441 0 54 44 57 -1442 0 57 44 48 -1443 0 48 44 36 -1444 0 36 44 32 -1445 0 94 95 109 -1446 0 109 95 112 -1447 0 30 40 31 -1448 0 31 40 43 -1449 0 109 112 129 -1450 0 109 129 128 -1451 0 129 112 132 -1452 0 129 132 150 -1453 0 150 132 153 -1454 0 153 132 138 -1455 0 138 132 118 -1456 0 118 132 112 -1457 0 128 129 147 -1458 0 128 147 148 -1459 0 148 147 168 -1460 0 168 147 169 -1461 0 169 147 150 -1462 0 147 129 150 -1463 0 31 43 33 -1464 0 31 33 24 -1465 0 24 33 28 -1466 0 238 220 247 -1467 0 238 247 271 -1468 0 271 247 277 -1469 0 247 220 227 -1470 0 289 282 314 -1471 0 314 282 307 -1472 0 314 307 339 -1473 0 314 339 347 -1474 0 339 307 334 -1475 0 334 307 303 -1476 0 334 303 327 -1477 0 327 303 297 -1478 0 297 303 273 -1479 0 273 303 276 -1480 0 276 303 307 -1481 0 339 334 365 -1482 0 339 365 374 -1483 0 374 365 399 -1484 0 365 334 360 -1485 0 360 334 327 -1486 0 360 327 356 -1487 0 356 327 324 -1488 0 324 327 297 -1489 0 399 365 394 -1490 0 399 394 424 -1491 0 394 365 360 -1492 0 394 360 390 -1493 0 390 360 356 -1494 0 390 356 386 -1495 0 386 356 353 -1496 0 353 356 324 -1497 0 353 324 321 -1498 0 321 324 292 -1499 0 292 324 297 -1500 0 307 282 276 -1501 0 276 282 253 -1502 0 276 253 248 -1503 0 248 253 226 -1504 0 248 226 221 -1505 0 221 226 199 -1506 0 226 253 230 -1507 0 199 226 203 -1508 0 203 226 230 -1509 0 199 203 178 -1510 0 199 178 174 -1511 0 174 178 156 -1512 0 156 178 162 -1513 0 156 162 140 -1514 0 156 140 134 -1515 0 134 140 119 -1516 0 119 140 125 -1517 0 156 134 152 -1518 0 156 152 174 -1519 0 174 152 172 -1520 0 172 152 148 -1521 0 148 152 130 -1522 0 130 152 134 -1523 0 130 134 115 -1524 0 115 134 119 -1525 0 424 394 420 -1526 0 420 394 390 -1527 0 420 390 415 -1528 0 415 390 386 -1529 0 420 415 442 -1530 0 442 415 440 -1531 0 440 415 411 -1532 0 411 415 386 -1533 0 440 411 438 -1534 0 438 411 410 -1535 0 440 438 463 -1536 0 463 438 461 -1537 0 461 438 439 -1538 0 461 439 466 -1539 0 466 439 441 -1540 0 441 439 413 -1541 0 413 439 410 -1542 0 410 439 438 -1543 0 410 411 382 -1544 0 410 382 384 -1545 0 384 382 352 -1546 0 352 382 353 -1547 0 384 352 354 -1548 0 354 352 322 -1549 0 322 352 321 -1550 0 322 321 291 -1551 0 291 321 292 -1552 0 353 382 386 -1553 0 386 382 411 -1554 0 321 352 353 -1555 0 291 292 264 -1556 0 291 264 265 -1557 0 265 264 239 -1558 0 265 239 243 -1559 0 243 239 215 -1560 0 215 239 214 -1561 0 214 239 240 -1562 0 240 239 264 -1563 0 240 264 267 -1564 0 240 267 244 -1565 0 267 264 292 -1566 0 267 292 297 -1567 0 244 267 273 -1568 0 267 297 273 -1569 0 276 248 273 -1570 0 273 248 244 -1571 0 244 248 221 -1572 0 244 221 217 -1573 0 244 217 240 -1574 0 217 221 195 -1575 0 195 221 199 -1576 0 195 199 174 -1577 0 195 174 172 -1578 0 195 172 191 -1579 0 191 172 168 -1580 0 168 172 148 -1581 0 240 217 214 -1582 0 214 217 191 -1583 0 191 217 195 -1584 0 214 191 190 -1585 0 214 190 215 -1586 0 190 191 168 -1587 0 190 168 169 -1588 0 190 169 193 -1589 0 193 169 173 -1590 0 173 169 150 -1591 0 193 173 197 -1592 0 193 197 218 -1593 0 197 173 176 -1594 0 218 197 223 -1595 0 176 173 153 -1596 0 153 173 150 -1597 0 223 197 201 -1598 0 201 197 176 -1599 0 201 176 180 -1600 0 201 180 206 -1601 0 206 180 188 -1602 0 188 180 164 -1603 0 164 180 157 -1604 0 157 180 176 -1605 0 157 176 153 -1606 0 157 153 138 -1607 0 157 138 142 -1608 0 142 138 120 -1609 0 157 142 164 -1610 0 164 142 149 -1611 0 120 138 118 -1612 0 149 142 126 -1613 0 149 126 139 -1614 0 139 126 116 -1615 0 116 126 106 -1616 0 106 126 120 -1617 0 126 142 120 -1618 0 215 190 193 -1619 0 215 193 218 -1620 0 215 218 243 -1621 0 243 218 245 -1622 0 243 245 270 -1623 0 245 218 223 -1624 0 245 223 250 -1625 0 250 223 228 -1626 0 228 223 201 -1627 0 228 201 206 -1628 0 228 206 234 -1629 0 234 206 216 -1630 0 228 234 256 -1631 0 270 245 274 -1632 0 256 234 263 -1633 0 216 206 188 -1634 0 274 245 250 -1635 0 274 250 278 -1636 0 274 278 305 -1637 0 278 250 256 -1638 0 256 250 228 -1639 0 305 278 309 -1640 0 263 234 246 -1641 0 305 309 337 -1642 0 309 278 285 -1643 0 285 278 256 -1644 0 246 234 216 -1645 0 337 309 342 -1646 0 342 309 318 -1647 0 337 342 368 -1648 0 368 342 376 -1649 0 376 342 351 -1650 0 318 309 285 -1651 0 351 342 318 -1652 0 351 318 329 -1653 0 351 329 362 -1654 0 362 329 345 -1655 0 329 318 295 -1656 0 295 318 285 -1657 0 345 329 306 -1658 0 345 306 320 -1659 0 306 329 295 -1660 0 320 306 288 -1661 0 288 306 275 -1662 0 275 306 295 -1663 0 275 295 263 -1664 0 263 295 285 -1665 0 285 256 263 -1666 0 275 263 246 -1667 0 243 270 265 -1668 0 265 270 294 -1669 0 294 270 298 -1670 0 298 270 274 -1671 0 294 298 326 -1672 0 326 298 330 -1673 0 330 298 305 -1674 0 305 298 274 -1675 0 330 305 337 -1676 0 330 337 361 -1677 0 330 361 357 -1678 0 361 337 368 -1679 0 361 368 397 -1680 0 397 368 402 -1681 0 402 368 376 -1682 0 402 376 408 -1683 0 408 376 388 -1684 0 357 361 392 -1685 0 330 357 326 -1686 0 326 357 354 -1687 0 388 376 351 -1688 0 392 361 397 -1689 0 392 397 421 -1690 0 421 397 426 -1691 0 426 397 402 -1692 0 426 402 431 -1693 0 421 426 450 -1694 0 450 426 454 -1695 0 431 402 408 -1696 0 431 408 453 -1697 0 454 426 431 -1698 0 454 431 473 -1699 0 354 357 387 -1700 0 354 387 384 -1701 0 387 357 392 -1702 0 387 392 418 -1703 0 418 392 421 -1704 0 418 421 444 -1705 0 444 421 450 -1706 0 444 450 471 -1707 0 471 450 484 -1708 0 384 387 413 -1709 0 384 413 410 -1710 0 413 387 418 -1711 0 413 418 441 -1712 0 441 418 444 -1713 0 441 444 469 -1714 0 441 469 466 -1715 0 469 444 471 -1716 0 469 471 494 -1717 0 469 494 490 -1718 0 490 494 516 -1719 0 516 494 519 -1720 0 519 494 507 -1721 0 519 507 531 -1722 0 494 471 507 -1723 0 466 469 490 -1724 0 466 490 487 -1725 0 466 487 461 -1726 0 487 490 513 -1727 0 487 513 511 -1728 0 513 490 516 -1729 0 513 516 539 -1730 0 539 516 543 -1731 0 543 516 519 -1732 0 543 519 545 -1733 0 543 545 568 -1734 0 568 545 571 -1735 0 571 545 531 -1736 0 531 545 519 -1737 0 294 326 322 -1738 0 322 326 354 -1739 0 294 322 291 -1740 0 294 291 265 -1741 0 347 339 374 -1742 0 347 374 381 -1743 0 381 374 407 -1744 0 381 407 416 -1745 0 407 374 399 -1746 0 416 407 436 -1747 0 416 436 446 -1748 0 416 446 427 -1749 0 436 407 428 -1750 0 436 428 457 -1751 0 457 428 452 -1752 0 428 407 399 -1753 0 428 399 424 -1754 0 428 424 452 -1755 0 116 106 96 -1756 0 116 96 114 -1757 0 116 114 136 -1758 0 96 106 88 -1759 0 88 106 102 -1760 0 102 106 120 -1761 0 96 88 77 -1762 0 96 77 93 -1763 0 96 93 114 -1764 0 77 88 71 -1765 0 71 88 84 -1766 0 71 84 69 -1767 0 69 84 81 -1768 0 77 71 62 -1769 0 62 71 57 -1770 0 57 71 69 -1771 0 84 88 102 -1772 0 62 57 48 -1773 0 62 48 61 -1774 0 62 61 76 -1775 0 90 103 85 -1776 0 148 130 128 -1777 0 408 388 432 -1778 0 650 662 676 -1779 0 1105 1078 1094 -1780 0 1094 1078 1074 -1781 0 1105 1094 1117 -1782 0 1117 1094 1113 -1783 0 1105 1117 1127 -1784 0 1127 1117 1140 -1785 0 1140 1117 1131 -1786 0 1140 1131 1157 -1787 0 1131 1117 1113 -1788 0 1105 1127 1111 -1789 0 1157 1131 1150 -1790 0 1150 1113 1119 -1791 0 237 269 254 -1792 0 237 254 225 -1793 0 225 254 241 -1794 0 241 254 288 -1795 0 237 225 210 -1796 0 225 241 211 -1797 0 211 241 216 -1798 0 211 216 188 -1799 0 254 269 284 -1800 0 254 284 288 -1801 0 288 284 320 -1802 0 284 269 302 -1803 0 210 225 198 -1804 0 210 198 183 -1805 0 183 198 171 -1806 0 171 198 185 -1807 0 171 185 149 -1808 0 183 171 159 -1809 0 159 171 139 -1810 0 284 302 317 -1811 0 284 317 320 -1812 0 320 317 348 -1813 0 348 317 336 -1814 0 320 348 345 -1815 0 317 302 336 -1816 0 185 198 211 -1817 0 211 198 225 -1818 0 185 211 188 -1819 0 185 188 164 -1820 0 246 216 241 -1821 0 246 241 275 -1822 0 624 644 618 -1823 0 624 618 599 -1824 0 599 618 593 -1825 0 593 618 600 -1826 0 593 600 569 -1827 0 618 644 625 -1828 0 618 625 600 -1829 0 934 912 913 -1830 0 934 913 935 -1831 0 935 913 923 -1832 0 935 923 946 -1833 0 934 935 957 -1834 0 913 912 891 -1835 0 913 891 899 -1836 0 913 899 923 -1837 0 891 912 890 -1838 0 891 890 868 -1839 0 868 890 870 -1840 0 868 870 846 -1841 0 868 846 847 -1842 0 891 868 871 -1843 0 871 868 847 -1844 0 946 923 925 -1845 0 847 846 825 -1846 0 846 870 849 -1847 0 957 935 964 -1848 0 891 871 899 -1849 0 512 511 534 -1850 0 1095 1096 1075 -1851 0 69 54 57 -1852 0 991 980 1004 -1853 0 991 1004 1016 -1854 0 991 1016 1006 -1855 0 1006 1016 1030 -1856 0 1030 1016 1039 -1857 0 1030 1039 1054 -1858 0 1054 1039 1065 -1859 0 1006 1030 1019 -1860 0 1065 1039 1053 -1861 0 1053 1039 1029 -1862 0 1029 1039 1016 -1863 0 1016 1004 1029 -1864 0 1006 1019 994 -1865 0 1006 994 981 -1866 0 981 994 970 -1867 0 970 994 983 -1868 0 1006 981 991 -1869 0 1019 1030 1043 -1870 0 1043 1030 1054 -1871 0 1019 1043 1031 -1872 0 1031 1043 1056 -1873 0 1031 1056 1046 -1874 0 1056 1043 1067 -1875 0 1067 1043 1054 -1876 0 1056 1067 1081 -1877 0 1056 1081 1069 -1878 0 1081 1067 1100 -1879 0 1069 1081 1101 -1880 0 1046 1056 1069 -1881 0 1031 1046 1022 -1882 0 1022 1046 1035 -1883 0 1067 1054 1076 -1884 0 1067 1076 1100 -1885 0 1076 1054 1065 -1886 0 1076 1065 1096 -1887 0 60 55 72 -1888 0 1106 1085 1071 -1889 0 755 751 731 -1890 0 731 751 726 -1891 0 755 731 752 -1892 0 755 752 776 -1893 0 731 726 706 -1894 0 706 726 700 -1895 0 706 700 668 -1896 0 700 726 716 -1897 0 731 706 714 -1898 0 731 714 752 -1899 0 714 706 674 -1900 0 700 716 692 -1901 0 700 692 672 -1902 0 672 692 670 -1903 0 672 670 648 -1904 0 672 648 668 -1905 0 672 668 700 -1906 0 164 149 185 -1907 0 141 161 135 -1908 0 493 523 505 -1909 0 505 523 532 -1910 0 493 505 479 -1911 0 532 523 550 -1912 0 532 550 562 -1913 0 532 562 551 -1914 0 562 550 576 -1915 0 551 562 577 -1916 0 505 532 525 -1917 0 525 532 551 -1918 0 525 551 538 -1919 0 538 551 567 -1920 0 567 551 577 -1921 0 567 577 594 -1922 0 562 576 589 -1923 0 589 576 601 -1924 0 562 589 577 -1925 0 479 505 497 -1926 0 497 505 525 -1927 0 479 497 468 -1928 0 468 497 482 -1929 0 482 497 509 -1930 0 509 497 525 -1931 0 468 482 455 -1932 0 455 482 472 -1933 0 468 455 437 -1934 0 437 455 425 -1935 0 437 425 406 -1936 0 425 455 443 -1937 0 472 482 500 -1938 0 406 425 395 -1939 0 395 425 412 -1940 0 395 412 362 -1941 0 500 482 509 -1942 0 509 525 538 -1943 0 412 425 443 -1944 0 412 443 432 -1945 0 412 432 388 -1946 0 443 455 472 -1947 0 479 468 451 -1948 0 479 451 462 -1949 0 462 451 434 -1950 0 434 451 422 -1951 0 434 422 404 -1952 0 404 422 389 -1953 0 422 451 437 -1954 0 422 437 406 -1955 0 389 422 406 -1956 0 389 406 375 -1957 0 375 406 395 -1958 0 375 395 345 -1959 0 451 468 437 -1960 0 479 462 493 -1961 0 404 389 370 -1962 0 370 389 348 -1963 0 538 567 554 -1964 0 389 375 348 -1965 0 348 375 345 -1966 0 1112 1114 1092 -1967 0 236 209 204 -1968 0 18 26 22 -1969 0 22 26 36 -1970 0 18 22 15 -1971 0 18 15 12 -1972 0 12 15 9 -1973 0 15 22 21 -1974 0 9 15 13 -1975 0 12 9 6 -1976 0 15 21 13 -1977 0 13 21 20 -1978 0 13 20 14 -1979 0 14 20 24 -1980 0 24 20 31 -1981 0 9 13 8 -1982 0 6 9 4 -1983 0 9 8 4 -1984 0 4 8 7 -1985 0 7 8 11 -1986 0 4 7 2 -1987 0 11 8 14 -1988 0 11 14 19 -1989 0 14 8 13 -1990 0 6 4 3 -1991 0 3 4 2 -1992 0 20 21 30 -1993 0 21 22 32 -1994 0 7 11 10 -1995 0 17 10 16 -1996 0 1191 1169 1184 -1997 0 880 869 857 -1998 0 359 347 381 -1999 0 432 453 408 -2000 0 105 113 92 -2001 0 853 852 834 -2002 0 853 834 839 -2003 0 853 839 859 -2004 0 859 839 842 -2005 0 853 859 876 -2006 0 859 842 865 -2007 0 834 852 820 -2008 0 839 834 803 -2009 0 842 839 811 -2010 0 1024 1049 1047 -2011 0 1101 1083 1069 -2012 0 369 335 371 -2013 0 136 159 139 -2014 0 136 139 116 -2015 0 1061 1042 1037 -2016 0 1023 999 1011 -2017 0 1023 1011 1044 -2018 0 689 685 708 -2019 0 48 36 47 -2020 0 48 47 61 -2021 0 644 668 648 -2022 0 644 648 625 -2023 0 135 113 122 -2024 0 1083 1101 1103 -2025 0 1129 1134 1110 -2026 0 229 255 236 -2027 0 611 602 626 -2028 0 626 602 622 -2029 0 626 622 647 -2030 0 838 820 852 -2031 0 34 25 29 -2032 0 351 362 388 -2033 0 388 362 412 -2034 0 502 481 474 -2035 0 340 371 335 -2036 0 1099 1100 1076 -2037 0 811 817 842 -2038 0 1082 1086 1112 -2039 0 27 19 28 -2040 0 845 854 872 -2041 0 1064 1044 1040 -2042 0 1040 1044 1011 -2043 0 1064 1040 1071 -2044 0 1042 1040 1014 -2045 0 288 275 241 -2046 0 769 795 782 -2047 0 32 30 21 -2048 0 862 860 830 -2049 0 800 803 834 -2050 0 820 800 834 -2051 0 182 158 161 -2052 0 1121 1126 1102 -2053 0 5 2 7 -2054 0 1091 1113 1094 -2055 0 1091 1094 1074 -2056 0 35 47 36 -2057 0 35 36 26 -2058 0 1147 1123 1145 -2059 0 484 507 471 -2060 0 120 118 102 -2061 0 798 780 818 -2062 0 833 848 817 -2063 0 453 480 473 -2064 0 453 473 431 -2065 0 803 811 839 -2066 0 1107 1109 1086 -2067 0 301 283 310 -2068 0 851 829 860 -2069 0 104 119 125 -2070 0 149 139 171 -2071 0 68 51 58 -2072 0 58 51 39 -2073 0 1053 1075 1065 -2074 0 1065 1075 1096 -2075 0 30 31 20 -2076 0 656 682 669 -2077 0 686 666 691 -2078 0 686 691 711 -2079 0 686 711 714 -2080 0 714 711 735 -2081 0 711 691 715 -2082 0 711 715 735 -2083 0 92 75 87 -2084 0 1144 1150 1119 -2085 0 1078 1068 1049 -2086 0 473 496 454 -2087 0 77 62 76 -2088 0 77 76 93 -2089 0 19 16 11 -2090 0 871 847 851 -2091 0 871 851 881 -2092 0 1096 1099 1076 -2093 0 817 798 833 -2094 0 1119 1104 1134 -2095 0 1085 1064 1071 -2096 0 946 964 935 -2097 0 36 32 22 -2098 0 836 838 864 -2099 0 1114 1090 1092 -2100 0 209 182 204 -2101 0 1102 1090 1121 -2102 0 10 5 7 -2103 0 1169 1147 1145 -2104 0 496 484 454 -2105 0 1011 1014 1040 -2106 0 1103 1107 1083 -2107 0 335 301 310 -2108 0 1068 1047 1049 -2109 0 668 674 706 -2110 0 881 899 871 -2111 0 113 105 122 -2112 0 1134 1144 1119 -2113 0 25 17 23 -2114 0 336 370 348 -2115 0 852 867 838 -2116 0 600 596 558 -2117 0 1100 1101 1081 -2118 0 450 454 484 -2119 0 860 881 851 -2120 0 674 686 714 -2121 0 1086 1073 1107 -2122 0 1126 1129 1110 -2123 0 158 135 161 -2124 0 1113 1150 1131 -2125 0 1125 1106 1108 -2126 0 1052 1074 1078 -2127 0 362 345 395 -2128 0 829 830 860 -2129 0 867 864 838 -2130 0 735 752 714 -2131 0 268 236 255 -2132 0 1109 1112 1086 -2133 0 255 283 268 -2134 0 830 836 862 -2135 0 75 60 72 -2136 0 28 19 24 -2137 0 11 16 10 -2138 0 14 24 19 -2139 0 1101 1100 1118 -2140 0 1191 1184 1212 -2141 0 1378 1364 1356 -2142 0 1101 1118 1122 -2143 0 1122 1118 1139 -2144 0 1139 1118 1138 -2145 0 1122 1139 1142 -2146 0 1122 1142 1124 -2147 0 1138 1118 1116 -2148 0 1124 1142 1146 -2149 0 1142 1139 1162 -2150 0 1162 1139 1161 -2151 0 1161 1139 1138 -2152 0 1116 1118 1100 -2153 0 1146 1142 1164 -2154 0 1164 1142 1162 -2155 0 1146 1164 1170 -2156 0 1164 1162 1187 -2157 0 1170 1164 1192 -2158 0 1192 1164 1187 -2159 0 1187 1162 1183 -2160 0 1187 1183 1209 -2161 0 1209 1183 1204 -2162 0 1204 1183 1181 -2163 0 1181 1183 1161 -2164 0 1161 1138 1159 -2165 0 1159 1138 1136 -2166 0 1136 1138 1116 -2167 0 1183 1162 1161 -2168 0 1428 1437 1413 -2169 0 1428 1413 1404 -2170 0 1404 1413 1392 -2171 0 1392 1413 1397 -2172 0 1392 1397 1375 -2173 0 1375 1397 1380 -2174 0 1397 1413 1418 -2175 0 1418 1413 1437 -2176 0 1418 1437 1441 -2177 0 1418 1441 1423 -2178 0 1423 1441 1446 -2179 0 1380 1397 1400 -2180 0 1418 1423 1400 -2181 0 1400 1423 1410 -2182 0 1410 1423 1434 -2183 0 1400 1397 1418 -2184 0 1423 1446 1434 -2185 0 1428 1404 1421 -2186 0 1421 1404 1399 -2187 0 1399 1404 1385 -2188 0 1399 1385 1377 -2189 0 1385 1404 1392 -2190 0 1377 1385 1365 -2191 0 1365 1385 1370 -2192 0 1370 1385 1392 -2193 0 1370 1392 1375 -2194 0 1365 1370 1348 -2195 0 1348 1370 1353 -2196 0 1353 1370 1375 -2197 0 1353 1375 1357 -2198 0 1357 1375 1380 -2199 0 1348 1353 1331 -2200 0 1331 1353 1336 -2201 0 1336 1353 1357 -2202 0 1336 1357 1346 -2203 0 1336 1346 1318 -2204 0 1346 1357 1367 -2205 0 1367 1357 1380 -2206 0 1318 1346 1329 -2207 0 1318 1329 1307 -2208 0 1307 1329 1313 -2209 0 1313 1329 1335 -2210 0 1335 1329 1352 -2211 0 1352 1329 1346 -2212 0 1352 1346 1367 -2213 0 1352 1367 1373 -2214 0 1373 1367 1391 -2215 0 1352 1373 1371 -2216 0 1391 1367 1380 -2217 0 1391 1380 1400 -2218 0 1391 1400 1410 -2219 0 1391 1411 1390 -2220 0 1336 1318 1314 -2221 0 1336 1314 1331 -2222 0 1331 1314 1309 -2223 0 1309 1314 1292 -2224 0 1292 1314 1297 -2225 0 1309 1292 1287 -2226 0 1297 1314 1318 -2227 0 1297 1318 1307 -2228 0 1297 1307 1285 -2229 0 1285 1307 1291 -2230 0 1291 1307 1313 -2231 0 1287 1292 1269 -2232 0 1269 1292 1274 -2233 0 1274 1292 1297 -2234 0 1285 1291 1267 -2235 0 1267 1291 1272 -2236 0 1272 1291 1296 -2237 0 1296 1291 1313 -2238 0 1285 1267 1255 -2239 0 1255 1267 1244 -2240 0 1244 1267 1249 -2241 0 1249 1267 1272 -2242 0 1287 1269 1263 -2243 0 1296 1313 1327 -2244 0 1287 1263 1278 -2245 0 1278 1263 1253 -2246 0 1287 1278 1305 -2247 0 1305 1278 1294 -2248 0 1294 1278 1271 -2249 0 1253 1263 1238 -2250 0 1271 1278 1253 -2251 0 1271 1253 1250 -2252 0 1250 1253 1230 -2253 0 1238 1263 1246 -2254 0 1238 1246 1220 -2255 0 1246 1263 1269 -2256 0 1220 1246 1228 -2257 0 1228 1246 1252 -2258 0 1252 1246 1269 -2259 0 1252 1269 1274 -2260 0 1220 1228 1203 -2261 0 1203 1228 1208 -2262 0 1208 1228 1231 -2263 0 1203 1208 1186 -2264 0 1186 1208 1194 -2265 0 1194 1208 1216 -2266 0 1216 1208 1231 -2267 0 1231 1228 1252 -2268 0 1230 1253 1238 -2269 0 1230 1238 1213 -2270 0 1213 1238 1220 -2271 0 1213 1220 1196 -2272 0 1196 1220 1203 -2273 0 1213 1196 1189 -2274 0 1189 1196 1174 -2275 0 1213 1189 1207 -2276 0 1207 1189 1185 -2277 0 1185 1189 1168 -2278 0 1168 1189 1174 -2279 0 1174 1196 1180 -2280 0 1180 1196 1203 -2281 0 1174 1180 1155 -2282 0 1174 1155 1151 -2283 0 1155 1180 1163 -2284 0 1151 1155 1134 -2285 0 1134 1155 1144 -2286 0 1144 1155 1163 -2287 0 1144 1163 1150 -2288 0 1150 1163 1171 -2289 0 1151 1134 1129 -2290 0 1151 1129 1148 -2291 0 1151 1148 1168 -2292 0 1168 1148 1165 -2293 0 1165 1148 1141 -2294 0 1168 1165 1185 -2295 0 1185 1165 1182 -2296 0 1148 1129 1126 -2297 0 1150 1171 1157 -2298 0 1171 1163 1186 -2299 0 1171 1186 1194 -2300 0 1171 1194 1175 -2301 0 1185 1182 1205 -2302 0 1182 1165 1160 -2303 0 1175 1194 1201 -2304 0 1171 1175 1157 -2305 0 1157 1175 1166 -2306 0 1166 1175 1188 -2307 0 1188 1175 1201 -2308 0 1188 1201 1210 -2309 0 1188 1210 1198 -2310 0 1210 1201 1225 -2311 0 1166 1188 1172 -2312 0 1225 1201 1216 -2313 0 1225 1216 1244 -2314 0 1225 1244 1249 -2315 0 1198 1210 1222 -2316 0 1210 1225 1232 -2317 0 1188 1198 1172 -2318 0 1172 1198 1184 -2319 0 1141 1148 1126 -2320 0 1141 1126 1121 -2321 0 1141 1121 1137 -2322 0 1165 1141 1160 -2323 0 1160 1141 1137 -2324 0 1160 1137 1154 -2325 0 1154 1137 1132 -2326 0 1160 1154 1177 -2327 0 1160 1177 1182 -2328 0 1182 1177 1202 -2329 0 1182 1202 1205 -2330 0 1205 1202 1224 -2331 0 1202 1177 1195 -2332 0 1224 1202 1219 -2333 0 1205 1224 1227 -2334 0 1195 1177 1173 -2335 0 1202 1195 1219 -2336 0 1154 1132 1153 -2337 0 1177 1154 1173 -2338 0 1173 1154 1153 -2339 0 1173 1153 1176 -2340 0 1173 1176 1193 -2341 0 1176 1153 1152 -2342 0 1132 1137 1114 -2343 0 1132 1114 1112 -2344 0 1185 1205 1207 -2345 0 1207 1205 1227 -2346 0 1207 1227 1230 -2347 0 1230 1227 1250 -2348 0 1250 1227 1245 -2349 0 1250 1245 1268 -2350 0 1245 1227 1224 -2351 0 1245 1224 1239 -2352 0 1239 1224 1219 -2353 0 1239 1219 1234 -2354 0 1245 1239 1264 -2355 0 1239 1234 1258 -2356 0 1234 1219 1211 -2357 0 1245 1264 1268 -2358 0 1268 1264 1286 -2359 0 1268 1286 1290 -2360 0 1286 1264 1275 -2361 0 1264 1239 1258 -2362 0 1264 1258 1275 -2363 0 1275 1258 1273 -2364 0 1275 1273 1295 -2365 0 1273 1258 1251 -2366 0 1251 1258 1234 -2367 0 1251 1234 1229 -2368 0 1251 1229 1247 -2369 0 1229 1234 1211 -2370 0 1229 1211 1206 -2371 0 1229 1206 1226 -2372 0 1206 1211 1193 -2373 0 1206 1193 1176 -2374 0 1193 1211 1195 -2375 0 1193 1195 1173 -2376 0 1195 1211 1219 -2377 0 1251 1247 1270 -2378 0 1247 1229 1226 -2379 0 1295 1273 1293 -2380 0 1275 1295 1299 -2381 0 1273 1251 1270 -2382 0 1273 1270 1293 -2383 0 1293 1270 1288 -2384 0 1293 1288 1310 -2385 0 1288 1270 1265 -2386 0 1268 1290 1271 -2387 0 1271 1290 1294 -2388 0 1290 1286 1308 -2389 0 1286 1275 1299 -2390 0 1286 1299 1308 -2391 0 1308 1299 1325 -2392 0 1226 1206 1197 -2393 0 1201 1194 1216 -2394 0 1265 1270 1247 -2395 0 1265 1247 1243 -2396 0 1265 1243 1262 -2397 0 1243 1247 1226 -2398 0 1243 1226 1217 -2399 0 1217 1226 1197 -2400 0 1217 1197 1192 -2401 0 1192 1197 1170 -2402 0 1243 1217 1242 -2403 0 1265 1262 1277 -2404 0 1262 1243 1242 -2405 0 1262 1242 1260 -2406 0 1260 1242 1237 -2407 0 1262 1260 1282 -2408 0 1242 1217 1218 -2409 0 1262 1282 1277 -2410 0 1277 1282 1298 -2411 0 1277 1298 1288 -2412 0 1298 1282 1304 -2413 0 1282 1260 1281 -2414 0 1237 1242 1218 -2415 0 1237 1218 1209 -2416 0 1209 1218 1187 -2417 0 1260 1237 1257 -2418 0 1310 1288 1298 -2419 0 1277 1288 1265 -2420 0 1293 1310 1315 -2421 0 1137 1121 1114 -2422 0 1325 1299 1316 -2423 0 1308 1325 1330 -2424 0 1222 1210 1232 -2425 0 1232 1225 1249 -2426 0 1232 1249 1254 -2427 0 1254 1249 1272 -2428 0 1232 1254 1240 -2429 0 1232 1240 1222 -2430 0 1222 1240 1233 -2431 0 1233 1240 1259 -2432 0 1259 1240 1254 -2433 0 1254 1272 1283 -2434 0 1198 1222 1212 -2435 0 1218 1217 1192 -2436 0 1298 1304 1323 -2437 0 1304 1282 1281 -2438 0 1304 1281 1301 -2439 0 1301 1281 1279 -2440 0 1304 1301 1321 -2441 0 1295 1293 1315 -2442 0 1299 1295 1316 -2443 0 1316 1295 1315 -2444 0 1250 1268 1271 -2445 0 1290 1308 1311 -2446 0 1176 1152 1170 -2447 0 1170 1152 1146 -2448 0 1152 1153 1130 -2449 0 1301 1279 1300 -2450 0 1321 1301 1320 -2451 0 1304 1321 1323 -2452 0 1323 1321 1344 -2453 0 1323 1344 1345 -2454 0 1344 1321 1341 -2455 0 1279 1281 1257 -2456 0 1197 1206 1176 -2457 0 1344 1341 1361 -2458 0 1341 1321 1320 -2459 0 1341 1320 1342 -2460 0 1342 1320 1319 -2461 0 1341 1342 1358 -2462 0 1345 1344 1363 -2463 0 1323 1345 1326 -2464 0 1153 1132 1130 -2465 0 1260 1257 1281 -2466 0 1358 1342 1360 -2467 0 1319 1320 1300 -2468 0 1257 1237 1236 -2469 0 1341 1358 1361 -2470 0 1361 1358 1386 -2471 0 1342 1319 1343 -2472 0 1319 1300 1303 -2473 0 1315 1310 1332 -2474 0 1330 1325 1347 -2475 0 1308 1330 1311 -2476 0 1325 1316 1338 -2477 0 1298 1323 1326 -2478 0 1298 1326 1310 -2479 0 1300 1279 1276 -2480 0 1320 1301 1300 -2481 0 1290 1311 1294 -2482 0 1294 1311 1317 -2483 0 1317 1311 1333 -2484 0 1294 1317 1305 -2485 0 1333 1311 1330 -2486 0 1333 1330 1351 -2487 0 1351 1330 1347 -2488 0 1333 1351 1354 -2489 0 1317 1333 1340 -2490 0 1333 1354 1340 -2491 0 1340 1354 1365 -2492 0 1354 1351 1372 -2493 0 1317 1340 1328 -2494 0 1372 1351 1368 -2495 0 1354 1372 1377 -2496 0 1152 1130 1128 -2497 0 1326 1345 1350 -2498 0 1317 1328 1305 -2499 0 1343 1319 1322 -2500 0 1236 1237 1209 -2501 0 1319 1303 1322 -2502 0 1322 1303 1302 -2503 0 1302 1303 1280 -2504 0 1322 1302 1324 -2505 0 1302 1280 1284 -2506 0 1280 1303 1276 -2507 0 1324 1302 1312 -2508 0 1322 1324 1339 -2509 0 1284 1280 1256 -2510 0 1302 1289 1312 -2511 0 1339 1324 1334 -2512 0 1322 1339 1343 -2513 0 1343 1339 1362 -2514 0 1362 1339 1364 -2515 0 1343 1362 1360 -2516 0 1360 1362 1383 -2517 0 1360 1383 1384 -2518 0 1364 1339 1334 -2519 0 1362 1364 1381 -2520 0 1362 1381 1383 -2521 0 1363 1344 1361 -2522 0 1342 1343 1360 -2523 0 1325 1338 1347 -2524 0 1315 1332 1337 -2525 0 1257 1236 1261 -2526 0 1338 1316 1337 -2527 0 1328 1340 1348 -2528 0 1328 1348 1331 -2529 0 1332 1310 1326 -2530 0 1345 1363 1369 -2531 0 1358 1360 1384 -2532 0 1303 1300 1276 -2533 0 1244 1216 1231 -2534 0 1163 1180 1186 -2535 0 1231 1252 1255 -2536 0 1255 1252 1274 -2537 0 1255 1274 1285 -2538 0 1285 1274 1297 -2539 0 1186 1180 1203 -2540 0 1331 1309 1328 -2541 0 1309 1287 1305 -2542 0 1309 1305 1328 -2543 0 1116 1100 1099 -2544 0 1116 1099 1115 -2545 0 1116 1115 1136 -2546 0 1115 1099 1096 -2547 0 1115 1096 1120 -2548 0 1136 1115 1135 -2549 0 1136 1135 1156 -2550 0 1156 1143 1167 -2551 0 1136 1156 1159 -2552 0 1135 1115 1120 -2553 0 1159 1156 1179 -2554 0 1159 1179 1181 -2555 0 1159 1181 1161 -2556 0 1179 1156 1178 -2557 0 1179 1178 1199 -2558 0 1179 1199 1200 -2559 0 1199 1178 1190 -2560 0 1200 1199 1221 -2561 0 1178 1156 1167 -2562 0 1200 1221 1223 -2563 0 1223 1221 1248 -2564 0 1223 1248 1236 -2565 0 1223 1236 1204 -2566 0 1200 1223 1204 -2567 0 1181 1179 1200 -2568 0 1181 1200 1204 -2569 0 1221 1199 1215 -2570 0 1215 1199 1190 -2571 0 1221 1215 1235 -2572 0 1235 1215 1241 -2573 0 1221 1235 1248 -2574 0 1248 1235 1256 -2575 0 1256 1235 1241 -2576 0 1231 1255 1244 -2577 0 1209 1204 1236 -2578 0 1394 1396 1374 -2579 0 1374 1396 1376 -2580 0 1374 1376 1355 -2581 0 1355 1376 1359 -2582 0 1355 1359 1337 -2583 0 1355 1337 1332 -2584 0 1376 1396 1398 -2585 0 1376 1398 1382 -2586 0 1382 1398 1402 -2587 0 1382 1402 1387 -2588 0 1387 1402 1405 -2589 0 1387 1405 1393 -2590 0 1376 1382 1359 -2591 0 1387 1393 1368 -2592 0 1394 1374 1369 -2593 0 1359 1382 1366 -2594 0 1359 1366 1338 -2595 0 1366 1382 1387 -2596 0 1366 1387 1368 -2597 0 1366 1368 1347 -2598 0 1393 1405 1412 -2599 0 1393 1412 1395 -2600 0 1393 1395 1372 -2601 0 1395 1412 1416 -2602 0 1395 1416 1399 -2603 0 1399 1416 1421 -2604 0 1395 1399 1377 -2605 0 1395 1377 1372 -2606 0 1374 1355 1350 -2607 0 1190 1214 1215 -2608 0 1371 1335 1352 -2609 0 1256 1280 1248 -2610 0 1384 1386 1358 -2611 0 1313 1335 1327 -2612 0 1455 1434 1446 -2613 0 1095 1120 1096 -2614 0 1112 1109 1130 -2615 0 1345 1369 1350 -2616 0 1289 1302 1284 -2617 0 1289 1284 1266 -2618 0 1283 1259 1254 -2619 0 1261 1236 1248 -2620 0 1261 1248 1276 -2621 0 1230 1213 1207 -2622 0 1368 1351 1347 -2623 0 1241 1266 1256 -2624 0 1327 1306 1296 -2625 0 1128 1130 1109 -2626 0 1388 1389 1363 -2627 0 1151 1168 1174 -2628 0 1284 1256 1266 -2629 0 1143 1156 1135 -2630 0 1411 1391 1410 -2631 0 1369 1363 1389 -2632 0 1107 1103 1124 -2633 0 1107 1124 1128 -2634 0 1124 1103 1122 -2635 0 1122 1103 1101 -2636 0 1334 1356 1364 -2637 0 1233 1212 1222 -2638 0 1379 1381 1364 -2639 0 1379 1364 1378 -2640 0 1373 1391 1390 -2641 0 1349 1327 1335 -2642 0 1214 1241 1215 -2643 0 1152 1128 1146 -2644 0 1146 1128 1124 -2645 0 1386 1388 1361 -2646 0 1377 1365 1354 -2647 0 1335 1371 1349 -2648 0 1434 1411 1410 -2649 0 1120 1143 1135 -2650 0 1109 1107 1128 -2651 0 1365 1348 1340 -2652 0 1315 1337 1316 -2653 0 1312 1334 1324 -2654 0 1326 1350 1332 -2655 0 1306 1283 1296 -2656 0 1372 1368 1393 -2657 0 1276 1279 1261 -2658 0 1389 1394 1369 -2659 0 1390 1371 1373 -2660 0 1272 1296 1283 -2661 0 1167 1190 1178 -2662 0 1257 1261 1279 -2663 0 1192 1187 1218 -2664 0 1350 1369 1374 -2665 0 1280 1276 1248 -2666 0 1347 1338 1366 -2667 0 1184 1198 1212 -2668 0 1363 1361 1388 -2669 0 1332 1350 1355 -2670 0 1132 1112 1130 -2671 0 1359 1338 1337 -2672 0 1176 1170 1197 -2673 0 1671 1673 1651 -2674 0 1378 1401 1379 -2675 0 1671 1651 1648 -2676 0 1648 1651 1627 -2677 0 1648 1627 1626 -2678 0 1626 1627 1605 -2679 0 1605 1627 1608 -2680 0 1608 1627 1629 -2681 0 1629 1627 1651 -2682 0 1629 1651 1653 -2683 0 1653 1651 1673 -2684 0 1629 1653 1632 -2685 0 1632 1653 1655 -2686 0 1629 1632 1610 -2687 0 1655 1653 1675 -2688 0 1610 1632 1612 -2689 0 1612 1632 1634 -2690 0 1634 1632 1655 -2691 0 1634 1655 1656 -2692 0 1656 1655 1677 -2693 0 1675 1653 1673 -2694 0 1677 1655 1675 -2695 0 1428 1421 1443 -2696 0 1443 1421 1439 -2697 0 1439 1421 1416 -2698 0 1428 1443 1451 -2699 0 1451 1443 1467 -2700 0 1428 1451 1437 -2701 0 1467 1443 1462 -2702 0 1462 1443 1439 -2703 0 1462 1439 1457 -2704 0 1457 1439 1435 -2705 0 1435 1439 1416 -2706 0 1457 1435 1452 -2707 0 1457 1452 1474 -2708 0 1452 1435 1430 -2709 0 1430 1435 1412 -2710 0 1412 1435 1416 -2711 0 1474 1452 1470 -2712 0 1474 1470 1493 -2713 0 1470 1452 1444 -2714 0 1444 1452 1430 -2715 0 1444 1430 1422 -2716 0 1422 1430 1405 -2717 0 1405 1430 1412 -2718 0 1493 1470 1489 -2719 0 1493 1489 1512 -2720 0 1512 1489 1507 -2721 0 1512 1507 1529 -2722 0 1507 1489 1483 -2723 0 1483 1489 1463 -2724 0 1463 1489 1470 -2725 0 1463 1470 1444 -2726 0 1529 1507 1524 -2727 0 1529 1524 1547 -2728 0 1547 1524 1542 -2729 0 1524 1507 1503 -2730 0 1503 1507 1483 -2731 0 1542 1524 1519 -2732 0 1519 1524 1503 -2733 0 1542 1519 1537 -2734 0 1519 1503 1498 -2735 0 1498 1503 1479 -2736 0 1479 1503 1483 -2737 0 1479 1483 1461 -2738 0 1537 1519 1516 -2739 0 1516 1519 1498 -2740 0 1461 1483 1463 -2741 0 1461 1463 1442 -2742 0 1442 1463 1444 -2743 0 1442 1444 1422 -2744 0 1442 1422 1420 -2745 0 1420 1422 1402 -2746 0 1402 1422 1405 -2747 0 1437 1451 1458 -2748 0 1437 1458 1441 -2749 0 1441 1458 1464 -2750 0 1458 1451 1473 -2751 0 1473 1451 1467 -2752 0 1473 1467 1488 -2753 0 1488 1467 1485 -2754 0 1485 1467 1462 -2755 0 1458 1473 1482 -2756 0 1482 1473 1495 -2757 0 1495 1473 1488 -2758 0 1485 1462 1480 -2759 0 1485 1480 1504 -2760 0 1504 1480 1499 -2761 0 1480 1462 1457 -2762 0 1499 1480 1474 -2763 0 1464 1458 1482 -2764 0 1480 1457 1474 -2765 0 1547 1542 1566 -2766 0 1566 1542 1560 -2767 0 1560 1542 1537 -2768 0 1566 1560 1583 -2769 0 1583 1560 1580 -2770 0 1580 1560 1557 -2771 0 1557 1560 1537 -2772 0 1566 1583 1586 -2773 0 1547 1566 1569 -2774 0 1569 1566 1586 -2775 0 1586 1583 1607 -2776 0 1586 1607 1611 -2777 0 1607 1583 1602 -2778 0 1611 1607 1630 -2779 0 1602 1583 1580 -2780 0 1630 1607 1624 -2781 0 1624 1607 1602 -2782 0 1630 1624 1650 -2783 0 1650 1624 1644 -2784 0 1644 1624 1623 -2785 0 1623 1624 1602 -2786 0 1630 1650 1654 -2787 0 1630 1654 1635 -2788 0 1635 1654 1657 -2789 0 1657 1654 1678 -2790 0 1654 1650 1674 -2791 0 1654 1674 1678 -2792 0 1674 1650 1667 -2793 0 1678 1674 1692 -2794 0 1678 1692 1696 -2795 0 1678 1696 1679 -2796 0 1692 1674 1688 -2797 0 1688 1674 1667 -2798 0 1688 1667 1684 -2799 0 1684 1667 1661 -2800 0 1661 1667 1644 -2801 0 1661 1644 1640 -2802 0 1640 1644 1623 -2803 0 1640 1623 1618 -2804 0 1661 1640 1659 -2805 0 1684 1661 1682 -2806 0 1679 1696 1699 -2807 0 1678 1679 1657 -2808 0 1657 1679 1660 -2809 0 1660 1679 1683 -2810 0 1657 1660 1637 -2811 0 1618 1623 1600 -2812 0 1640 1618 1638 -2813 0 1683 1679 1699 -2814 0 1683 1699 1702 -2815 0 1683 1702 1686 -2816 0 1637 1660 1641 -2817 0 1659 1640 1638 -2818 0 1659 1638 1656 -2819 0 1656 1638 1634 -2820 0 1660 1683 1664 -2821 0 1657 1637 1635 -2822 0 1635 1637 1614 -2823 0 1614 1637 1621 -2824 0 1635 1614 1611 -2825 0 1611 1614 1592 -2826 0 1611 1592 1586 -2827 0 1586 1592 1569 -2828 0 1569 1592 1574 -2829 0 1592 1614 1597 -2830 0 1569 1574 1552 -2831 0 1574 1592 1597 -2832 0 1574 1597 1578 -2833 0 1574 1578 1556 -2834 0 1578 1597 1601 -2835 0 1661 1659 1682 -2836 0 1682 1659 1680 -2837 0 1680 1659 1656 -2838 0 1614 1621 1597 -2839 0 1597 1621 1601 -2840 0 1601 1621 1625 -2841 0 1601 1625 1609 -2842 0 1625 1621 1641 -2843 0 1625 1641 1649 -2844 0 1641 1621 1637 -2845 0 1649 1641 1664 -2846 0 1649 1664 1672 -2847 0 1649 1672 1652 -2848 0 1672 1664 1686 -2849 0 1672 1686 1695 -2850 0 1686 1664 1683 -2851 0 1625 1649 1633 -2852 0 1672 1695 1676 -2853 0 1695 1686 1706 -2854 0 1695 1706 1715 -2855 0 1652 1672 1676 -2856 0 1649 1652 1633 -2857 0 1633 1652 1636 -2858 0 1636 1652 1658 -2859 0 1633 1636 1613 -2860 0 1625 1633 1609 -2861 0 1609 1633 1613 -2862 0 1609 1613 1590 -2863 0 1609 1590 1591 -2864 0 1590 1613 1596 -2865 0 1591 1590 1567 -2866 0 1609 1591 1601 -2867 0 1601 1591 1578 -2868 0 1578 1591 1567 -2869 0 1590 1596 1573 -2870 0 1596 1613 1617 -2871 0 1613 1636 1617 -2872 0 1617 1636 1642 -2873 0 1642 1636 1658 -2874 0 1617 1642 1622 -2875 0 1642 1658 1663 -2876 0 1658 1652 1676 -2877 0 1658 1676 1681 -2878 0 1681 1676 1698 -2879 0 1658 1681 1663 -2880 0 1663 1681 1685 -2881 0 1663 1685 1670 -2882 0 1685 1681 1701 -2883 0 1617 1622 1599 -2884 0 1622 1642 1646 -2885 0 1670 1685 1687 -2886 0 1670 1687 1662 -2887 0 1670 1662 1646 -2888 0 1670 1646 1663 -2889 0 1701 1681 1698 -2890 0 1701 1698 1718 -2891 0 1701 1718 1722 -2892 0 1685 1701 1708 -2893 0 1676 1695 1698 -2894 0 1600 1623 1602 -2895 0 1600 1602 1580 -2896 0 1600 1580 1577 -2897 0 1577 1580 1557 -2898 0 1600 1577 1598 -2899 0 1638 1618 1615 -2900 0 1618 1600 1598 -2901 0 1618 1598 1615 -2902 0 1615 1598 1594 -2903 0 1615 1594 1612 -2904 0 1612 1594 1587 -2905 0 1594 1598 1575 -2906 0 1695 1715 1698 -2907 0 1698 1715 1718 -2908 0 1642 1663 1646 -2909 0 1686 1702 1706 -2910 0 1612 1587 1610 -2911 0 1587 1594 1572 -2912 0 1556 1578 1567 -2913 0 1574 1556 1552 -2914 0 1552 1556 1533 -2915 0 1533 1556 1539 -2916 0 1552 1533 1529 -2917 0 1598 1577 1575 -2918 0 1575 1577 1555 -2919 0 1555 1577 1557 -2920 0 1555 1557 1536 -2921 0 1575 1555 1554 -2922 0 1536 1557 1537 -2923 0 1536 1537 1516 -2924 0 1555 1536 1534 -2925 0 1536 1516 1514 -2926 0 1575 1554 1572 -2927 0 1572 1554 1550 -2928 0 1550 1554 1532 -2929 0 1572 1550 1568 -2930 0 1575 1572 1594 -2931 0 1568 1550 1548 -2932 0 1550 1532 1528 -2933 0 1572 1568 1587 -2934 0 1587 1568 1585 -2935 0 1585 1568 1564 -2936 0 1587 1585 1610 -2937 0 1610 1585 1608 -2938 0 1564 1568 1548 -2939 0 1564 1548 1544 -2940 0 1564 1544 1563 -2941 0 1544 1548 1526 -2942 0 1585 1564 1582 -2943 0 1532 1554 1534 -2944 0 1532 1534 1513 -2945 0 1534 1554 1555 -2946 0 1532 1513 1511 -2947 0 1513 1534 1514 -2948 0 1513 1514 1494 -2949 0 1513 1494 1492 -2950 0 1494 1514 1497 -2951 0 1514 1534 1536 -2952 0 1492 1494 1471 -2953 0 1513 1492 1511 -2954 0 1511 1492 1491 -2955 0 1511 1491 1510 -2956 0 1491 1492 1469 -2957 0 1494 1497 1475 -2958 0 1497 1514 1516 -2959 0 1497 1516 1498 -2960 0 1497 1498 1476 -2961 0 1497 1476 1475 -2962 0 1475 1476 1454 -2963 0 1475 1454 1453 -2964 0 1454 1476 1460 -2965 0 1476 1498 1479 -2966 0 1453 1454 1436 -2967 0 1475 1453 1471 -2968 0 1471 1453 1450 -2969 0 1471 1450 1469 -2970 0 1471 1469 1492 -2971 0 1450 1453 1433 -2972 0 1469 1450 1447 -2973 0 1460 1476 1479 -2974 0 1460 1479 1461 -2975 0 1460 1461 1440 -2976 0 1454 1460 1438 -2977 0 1532 1511 1528 -2978 0 1528 1511 1510 -2979 0 1528 1510 1526 -2980 0 1526 1510 1505 -2981 0 1528 1526 1548 -2982 0 1505 1510 1486 -2983 0 1526 1505 1525 -2984 0 1526 1525 1544 -2985 0 1544 1525 1543 -2986 0 1543 1525 1522 -2987 0 1544 1543 1563 -2988 0 1563 1543 1562 -2989 0 1562 1543 1541 -2990 0 1563 1562 1584 -2991 0 1486 1510 1491 -2992 0 1486 1491 1466 -2993 0 1466 1491 1469 -2994 0 1466 1469 1447 -2995 0 1466 1447 1448 -2996 0 1486 1466 1465 -2997 0 1466 1448 1465 -2998 0 1465 1448 1445 -2999 0 1445 1448 1426 -3000 0 1465 1445 1468 -3001 0 1448 1447 1427 -3002 0 1486 1465 1487 -3003 0 1505 1486 1487 -3004 0 1505 1487 1506 -3005 0 1506 1487 1484 -3006 0 1505 1506 1525 -3007 0 1525 1506 1522 -3008 0 1522 1506 1502 -3009 0 1502 1506 1484 -3010 0 1502 1484 1481 -3011 0 1522 1502 1520 -3012 0 1502 1481 1500 -3013 0 1481 1484 1456 -3014 0 1484 1487 1468 -3015 0 1484 1468 1456 -3016 0 1456 1468 1445 -3017 0 1468 1487 1465 -3018 0 1564 1563 1582 -3019 0 1582 1563 1584 -3020 0 1582 1584 1605 -3021 0 1605 1584 1603 -3022 0 1605 1603 1626 -3023 0 1603 1584 1589 -3024 0 1445 1426 1425 -3025 0 1426 1448 1427 -3026 0 1426 1427 1406 -3027 0 1406 1427 1409 -3028 0 1426 1406 1408 -3029 0 1543 1522 1541 -3030 0 1520 1502 1500 -3031 0 1520 1500 1518 -3032 0 1522 1520 1541 -3033 0 1427 1447 1429 -3034 0 1518 1500 1496 -3035 0 1520 1518 1538 -3036 0 1500 1481 1478 -3037 0 1440 1461 1442 -3038 0 1481 1456 1459 -3039 0 1460 1440 1438 -3040 0 1438 1440 1419 -3041 0 1438 1419 1417 -3042 0 1419 1440 1420 -3043 0 1417 1419 1396 -3044 0 1438 1417 1436 -3045 0 1436 1417 1415 -3046 0 1415 1417 1394 -3047 0 1436 1415 1433 -3048 0 1436 1433 1453 -3049 0 1433 1415 1414 -3050 0 1414 1415 1389 -3051 0 1433 1414 1429 -3052 0 1429 1414 1409 -3053 0 1429 1409 1427 -3054 0 1450 1433 1429 -3055 0 1406 1409 1386 -3056 0 1408 1406 1384 -3057 0 1426 1408 1425 -3058 0 1425 1408 1407 -3059 0 1425 1407 1432 -3060 0 1407 1408 1383 -3061 0 1447 1450 1429 -3062 0 1432 1407 1403 -3063 0 1425 1432 1456 -3064 0 1454 1438 1436 -3065 0 1471 1494 1475 -3066 0 1562 1541 1561 -3067 0 1590 1573 1567 -3068 0 1596 1617 1599 -3069 0 1596 1599 1576 -3070 0 1576 1599 1581 -3071 0 1596 1576 1573 -3072 0 1573 1576 1553 -3073 0 1573 1553 1549 -3074 0 1553 1576 1558 -3075 0 1576 1581 1558 -3076 0 1558 1581 1565 -3077 0 1581 1599 1604 -3078 0 1565 1581 1588 -3079 0 1558 1565 1540 -3080 0 1549 1553 1531 -3081 0 1573 1549 1567 -3082 0 1553 1558 1535 -3083 0 1585 1582 1608 -3084 0 1550 1528 1548 -3085 0 1569 1552 1547 -3086 0 1445 1425 1456 -3087 0 1539 1556 1567 -3088 0 1533 1539 1515 -3089 0 1660 1664 1641 -3090 0 1520 1538 1541 -3091 0 1541 1538 1561 -3092 0 1599 1622 1604 -3093 0 1604 1622 1628 -3094 0 1604 1628 1616 -3095 0 1628 1622 1646 -3096 0 1628 1646 1639 -3097 0 1481 1459 1478 -3098 0 1538 1518 1545 -3099 0 1500 1478 1496 -3100 0 1459 1456 1432 -3101 0 1581 1604 1588 -3102 0 1588 1604 1616 -3103 0 1638 1615 1634 -3104 0 1634 1615 1612 -3105 0 1558 1540 1535 -3106 0 1535 1540 1517 -3107 0 1517 1540 1530 -3108 0 1535 1517 1509 -3109 0 1565 1588 1571 -3110 0 1540 1565 1551 -3111 0 1549 1531 1527 -3112 0 1553 1535 1531 -3113 0 1432 1403 1431 -3114 0 1403 1407 1381 -3115 0 1562 1561 1589 -3116 0 1515 1539 1527 -3117 0 1509 1517 1495 -3118 0 1495 1517 1508 -3119 0 1530 1540 1551 -3120 0 1530 1546 1523 -3121 0 1533 1515 1512 -3122 0 1535 1509 1531 -3123 0 1551 1565 1571 -3124 0 1527 1531 1504 -3125 0 1527 1504 1499 -3126 0 1431 1403 1401 -3127 0 1549 1527 1539 -3128 0 1432 1431 1459 -3129 0 1610 1608 1629 -3130 0 1667 1650 1644 -3131 0 1728 1708 1722 -3132 0 1499 1474 1493 -3133 0 1499 1493 1515 -3134 0 1570 1595 1579 -3135 0 1570 1579 1559 -3136 0 1579 1595 1606 -3137 0 1579 1606 1589 -3138 0 1606 1595 1619 -3139 0 1606 1619 1631 -3140 0 1606 1631 1620 -3141 0 1631 1619 1643 -3142 0 1631 1643 1666 -3143 0 1620 1631 1645 -3144 0 1620 1647 1626 -3145 0 1645 1631 1666 -3146 0 1570 1559 1545 -3147 0 1545 1559 1538 -3148 0 1538 1559 1561 -3149 0 1561 1559 1579 -3150 0 1546 1530 1551 -3151 0 1546 1551 1571 -3152 0 1394 1389 1415 -3153 0 1680 1656 1677 -3154 0 1639 1616 1628 -3155 0 1639 1646 1662 -3156 0 1472 1496 1478 -3157 0 1472 1478 1449 -3158 0 1589 1561 1579 -3159 0 1482 1495 1508 -3160 0 1508 1517 1530 -3161 0 1508 1530 1523 -3162 0 1482 1508 1490 -3163 0 1490 1508 1523 -3164 0 1482 1490 1464 -3165 0 1464 1490 1477 -3166 0 1455 1446 1477 -3167 0 1665 1666 1643 -3168 0 1441 1464 1446 -3169 0 1446 1464 1477 -3170 0 1384 1383 1408 -3171 0 1424 1449 1431 -3172 0 1606 1620 1589 -3173 0 1442 1420 1440 -3174 0 1501 1477 1490 -3175 0 1611 1630 1635 -3176 0 1388 1386 1409 -3177 0 1593 1571 1588 -3178 0 1593 1588 1616 -3179 0 1521 1545 1518 -3180 0 1521 1518 1496 -3181 0 1398 1396 1419 -3182 0 1668 1669 1647 -3183 0 1647 1669 1648 -3184 0 1648 1669 1671 -3185 0 1668 1647 1645 -3186 0 1645 1647 1620 -3187 0 1626 1647 1648 -3188 0 1495 1488 1509 -3189 0 1509 1488 1485 -3190 0 1381 1379 1403 -3191 0 1708 1687 1685 -3192 0 1401 1424 1431 -3193 0 1420 1402 1398 -3194 0 1420 1398 1419 -3195 0 1523 1501 1490 -3196 0 1562 1589 1584 -3197 0 1603 1589 1620 -3198 0 1389 1388 1414 -3199 0 1485 1504 1509 -3200 0 1666 1668 1645 -3201 0 1512 1529 1533 -3202 0 1383 1381 1407 -3203 0 1605 1608 1582 -3204 0 1529 1547 1552 -3205 0 1493 1512 1515 -3206 0 1386 1384 1406 -3207 0 1396 1394 1417 -3208 0 1409 1414 1388 -3209 0 1499 1515 1527 -3210 0 1531 1509 1504 -3211 0 1701 1722 1708 -3212 0 1478 1459 1449 -3213 0 1567 1549 1539 -3214 0 1603 1620 1626 -3215 0 1459 1431 1449 -3216 0 1403 1379 1401 -3217 0 2836 2828 2835 -3218 0 1671 1669 1691 -3219 0 2827 2829 2805 -3220 0 1671 1691 1694 -3221 0 1691 1669 1690 -3222 0 1694 1691 1711 -3223 0 1690 1669 1668 -3224 0 1711 1691 1709 -3225 0 1709 1691 1690 -3226 0 1711 1709 1726 -3227 0 1726 1709 1725 -3228 0 1711 1726 1729 -3229 0 1725 1709 1707 -3230 0 1729 1726 1755 -3231 0 1755 1726 1753 -3232 0 1753 1726 1725 -3233 0 1753 1725 1746 -3234 0 1746 1725 1730 -3235 0 1730 1725 1707 -3236 0 2805 2829 2808 -3237 0 2808 2829 2830 -3238 0 1707 1709 1690 -3239 0 2805 2808 2791 -3240 0 2791 2808 2796 -3241 0 2796 2808 2811 -3242 0 2791 2796 2769 -3243 0 2769 2796 2778 -3244 0 2811 2808 2830 -3245 0 2811 2830 2831 -3246 0 2811 2831 2818 -3247 0 2778 2796 2799 -3248 0 2799 2796 2811 -3249 0 2799 2811 2818 -3250 0 2799 2818 2802 -3251 0 2802 2818 2823 -3252 0 2823 2818 2832 -3253 0 2818 2831 2832 -3254 0 1707 1690 1689 -3255 0 1689 1690 1668 -3256 0 1707 1689 1705 -3257 0 1705 1689 1693 -3258 0 1707 1705 1730 -3259 0 1730 1705 1735 -3260 0 2103 2079 2085 -3261 0 2103 2085 2109 -3262 0 2085 2079 2062 -3263 0 2109 2085 2091 -3264 0 2091 2085 2068 -3265 0 2068 2085 2062 -3266 0 2091 2068 2077 -3267 0 2062 2079 2055 -3268 0 2077 2068 2053 -3269 0 2077 2053 2060 -3270 0 2060 2053 2037 -3271 0 2091 2077 2100 -3272 0 2100 2077 2084 -3273 0 2084 2077 2060 -3274 0 2053 2068 2044 -3275 0 2053 2044 2029 -3276 0 2029 2044 2021 -3277 0 2021 2044 2038 -3278 0 2044 2068 2062 -3279 0 2038 2044 2062 -3280 0 2038 2062 2055 -3281 0 2037 2053 2029 -3282 0 2037 2029 2013 -3283 0 2013 2029 2005 -3284 0 2005 2029 2021 -3285 0 2005 2021 1997 -3286 0 1997 2021 2015 -3287 0 2005 1997 1981 -3288 0 1981 1997 1973 -3289 0 1973 1997 1992 -3290 0 2015 2021 2038 -3291 0 2015 2038 2031 -3292 0 1992 1997 2015 -3293 0 2038 2055 2031 -3294 0 2037 2013 2019 -3295 0 2037 2019 2043 -3296 0 2043 2019 2030 -3297 0 2030 2019 2006 -3298 0 2006 2019 1995 -3299 0 1995 2019 2013 -3300 0 2030 2006 2014 -3301 0 2014 2006 1990 -3302 0 1990 2006 1982 -3303 0 1982 2006 1995 -3304 0 2030 2014 2039 -3305 0 2030 2039 2054 -3306 0 2054 2039 2063 -3307 0 2039 2014 2022 -3308 0 2063 2039 2046 -3309 0 2046 2039 2022 -3310 0 2022 2014 1998 -3311 0 1998 2014 1990 -3312 0 2022 1998 2009 -3313 0 2009 1998 1985 -3314 0 1985 1998 1976 -3315 0 1976 1998 1990 -3316 0 2022 2009 2033 -3317 0 2022 2033 2046 -3318 0 2033 2009 2017 -3319 0 2033 2017 2041 -3320 0 2041 2017 2027 -3321 0 2027 2017 2003 -3322 0 2003 2017 1993 -3323 0 1993 2017 2009 -3324 0 2046 2033 2056 -3325 0 2056 2033 2041 -3326 0 2046 2056 2070 -3327 0 2070 2056 2080 -3328 0 2080 2056 2065 -3329 0 2065 2056 2041 -3330 0 2046 2070 2063 -3331 0 2063 2070 2087 -3332 0 2063 2087 2078 -3333 0 2078 2087 2102 -3334 0 2102 2087 2111 -3335 0 2111 2087 2094 -3336 0 2094 2087 2070 -3337 0 2094 2070 2080 -3338 0 2094 2080 2104 -3339 0 2094 2104 2118 -3340 0 2118 2104 2128 -3341 0 2104 2080 2089 -3342 0 2089 2080 2065 -3343 0 2128 2104 2113 -3344 0 2113 2104 2089 -3345 0 2113 2089 2099 -3346 0 2099 2089 2075 -3347 0 2075 2089 2065 -3348 0 2128 2113 2137 -3349 0 2128 2137 2152 -3350 0 2152 2137 2161 -3351 0 2137 2113 2122 -3352 0 2122 2113 2099 -3353 0 2122 2099 2106 -3354 0 2106 2099 2082 -3355 0 2161 2137 2146 -3356 0 2146 2137 2122 -3357 0 2146 2122 2130 -3358 0 2130 2122 2106 -3359 0 2130 2106 2117 -3360 0 2117 2106 2093 -3361 0 2093 2106 2082 -3362 0 2082 2099 2075 -3363 0 2082 2075 2059 -3364 0 2059 2075 2051 -3365 0 2051 2075 2065 -3366 0 2059 2051 2035 -3367 0 2059 2035 2045 -3368 0 2035 2051 2027 -3369 0 2045 2035 2020 -3370 0 2020 2035 2011 -3371 0 2011 2035 2027 -3372 0 2027 2051 2041 -3373 0 2041 2051 2065 -3374 0 1995 2013 1989 -3375 0 1989 2013 2005 -3376 0 1995 1989 1972 -3377 0 1995 1972 1982 -3378 0 1982 1972 1957 -3379 0 1957 1972 1948 -3380 0 1948 1972 1965 -3381 0 1965 1972 1989 -3382 0 1965 1989 1981 -3383 0 1981 1989 2005 -3384 0 1965 1981 1958 -3385 0 1958 1981 1973 -3386 0 1965 1958 1941 -3387 0 1941 1958 1934 -3388 0 1934 1958 1951 -3389 0 1934 1951 1927 -3390 0 1927 1951 1944 -3391 0 1944 1951 1968 -3392 0 1968 1951 1973 -3393 0 1973 1951 1958 -3394 0 2037 2043 2060 -3395 0 2060 2043 2067 -3396 0 2067 2043 2054 -3397 0 2067 2054 2078 -3398 0 2078 2054 2063 -3399 0 2060 2067 2084 -3400 0 2054 2043 2030 -3401 0 2084 2067 2092 -3402 0 2084 2092 2108 -3403 0 2108 2092 2116 -3404 0 2116 2092 2102 -3405 0 2102 2092 2078 -3406 0 2078 2092 2067 -3407 0 2108 2116 2131 -3408 0 2108 2131 2124 -3409 0 2108 2124 2100 -3410 0 2124 2131 2148 -3411 0 2148 2131 2154 -3412 0 2100 2124 2115 -3413 0 2154 2131 2140 -3414 0 2131 2116 2140 -3415 0 2140 2116 2126 -3416 0 2126 2116 2102 -3417 0 2140 2126 2150 -3418 0 2150 2126 2134 -3419 0 2140 2150 2164 -3420 0 2164 2150 2174 -3421 0 2174 2150 2158 -3422 0 2164 2174 2188 -3423 0 2188 2174 2198 -3424 0 2198 2174 2182 -3425 0 2182 2174 2158 -3426 0 2134 2126 2111 -3427 0 2111 2126 2102 -3428 0 2134 2111 2118 -3429 0 2134 2118 2142 -3430 0 2142 2118 2128 -3431 0 2142 2128 2152 -3432 0 2142 2152 2166 -3433 0 2166 2152 2176 -3434 0 2176 2152 2161 -3435 0 2158 2150 2134 -3436 0 2158 2134 2142 -3437 0 2158 2142 2166 -3438 0 2158 2166 2182 -3439 0 2182 2166 2190 -3440 0 2190 2166 2176 -3441 0 2190 2176 2200 -3442 0 2200 2176 2185 -3443 0 2200 2185 2209 -3444 0 2185 2176 2161 -3445 0 2185 2161 2170 -3446 0 2170 2161 2146 -3447 0 2185 2170 2194 -3448 0 2209 2185 2194 -3449 0 2209 2194 2218 -3450 0 2218 2194 2204 -3451 0 2170 2146 2155 -3452 0 2155 2146 2130 -3453 0 2204 2194 2180 -3454 0 2180 2194 2170 -3455 0 2180 2170 2155 -3456 0 2180 2155 2165 -3457 0 2180 2165 2189 -3458 0 2165 2155 2141 -3459 0 2141 2155 2130 -3460 0 2189 2165 2177 -3461 0 2177 2165 2153 -3462 0 2189 2177 2201 -3463 0 2153 2165 2141 -3464 0 2201 2177 2186 -3465 0 2186 2177 2162 -3466 0 2162 2177 2153 -3467 0 2162 2153 2138 -3468 0 2138 2153 2129 -3469 0 2129 2153 2141 -3470 0 2129 2141 2117 -3471 0 2115 2124 2139 -3472 0 2139 2124 2148 -3473 0 2141 2130 2117 -3474 0 2129 2117 2105 -3475 0 2105 2117 2093 -3476 0 2129 2105 2114 -3477 0 2114 2105 2090 -3478 0 2090 2105 2081 -3479 0 2114 2090 2101 -3480 0 2081 2105 2093 -3481 0 2101 2090 2076 -3482 0 2076 2090 2066 -3483 0 2066 2090 2081 -3484 0 2066 2081 2057 -3485 0 2057 2081 2069 -3486 0 2069 2081 2093 -3487 0 2069 2093 2082 -3488 0 2101 2076 2088 -3489 0 2088 2076 2064 -3490 0 2064 2076 2052 -3491 0 2052 2076 2066 -3492 0 2101 2088 2112 -3493 0 2101 2112 2125 -3494 0 2125 2112 2136 -3495 0 2136 2112 2123 -3496 0 2123 2112 2098 -3497 0 2098 2112 2088 -3498 0 2098 2088 2074 -3499 0 2074 2088 2064 -3500 0 2098 2074 2086 -3501 0 2098 2086 2110 -3502 0 2110 2086 2097 -3503 0 2097 2086 2073 -3504 0 2073 2086 2061 -3505 0 2061 2086 2074 -3506 0 2061 2074 2050 -3507 0 2061 2050 2036 -3508 0 2036 2050 2026 -3509 0 2026 2050 2040 -3510 0 2040 2050 2064 -3511 0 2050 2074 2064 -3512 0 2129 2114 2138 -3513 0 2069 2082 2059 -3514 0 2138 2114 2125 -3515 0 2125 2114 2101 -3516 0 2138 2125 2151 -3517 0 2151 2125 2136 -3518 0 2138 2151 2162 -3519 0 2162 2151 2175 -3520 0 2162 2175 2186 -3521 0 2175 2151 2160 -3522 0 2160 2151 2136 -3523 0 2069 2059 2045 -3524 0 2069 2045 2057 -3525 0 2186 2175 2199 -3526 0 2199 2175 2184 -3527 0 2184 2175 2160 -3528 0 2199 2184 2208 -3529 0 2208 2184 2195 -3530 0 2199 2208 2223 -3531 0 2195 2184 2171 -3532 0 2223 2208 2232 -3533 0 2232 2208 2219 -3534 0 2223 2232 2247 -3535 0 2219 2208 2195 -3536 0 2171 2184 2160 -3537 0 2247 2232 2256 -3538 0 2256 2232 2244 -3539 0 2244 2232 2219 -3540 0 2256 2244 2269 -3541 0 2269 2244 2255 -3542 0 2256 2269 2280 -3543 0 2255 2244 2231 -3544 0 2280 2269 2293 -3545 0 2293 2269 2279 -3546 0 2279 2269 2255 -3547 0 2279 2255 2265 -3548 0 2265 2255 2241 -3549 0 2241 2255 2231 -3550 0 2231 2244 2219 -3551 0 2231 2219 2207 -3552 0 2207 2219 2195 -3553 0 2207 2195 2183 -3554 0 2183 2195 2171 -3555 0 2183 2171 2159 -3556 0 2159 2171 2147 -3557 0 2159 2147 2135 -3558 0 2135 2147 2123 -3559 0 2147 2171 2160 -3560 0 2147 2160 2136 -3561 0 2147 2136 2123 -3562 0 2057 2045 2032 -3563 0 2057 2032 2042 -3564 0 2042 2032 2018 -3565 0 2042 2018 2028 -3566 0 2018 2032 2008 -3567 0 2008 2032 2020 -3568 0 2028 2018 2004 -3569 0 2004 2018 1994 -3570 0 1994 2018 2008 -3571 0 2057 2042 2066 -3572 0 2032 2045 2020 -3573 0 2066 2042 2052 -3574 0 2052 2042 2028 -3575 0 2052 2028 2040 -3576 0 2052 2040 2064 -3577 0 2040 2028 2016 -3578 0 2040 2016 2026 -3579 0 2016 2028 2004 -3580 0 2026 2016 2002 -3581 0 2002 2016 1991 -3582 0 1991 2016 2004 -3583 0 2026 2002 2012 -3584 0 2012 2002 1988 -3585 0 1988 2002 1978 -3586 0 2012 1988 2001 -3587 0 2001 1988 1977 -3588 0 1977 1988 1964 -3589 0 1978 2002 1991 -3590 0 1978 1991 1967 -3591 0 1967 1991 1980 -3592 0 1980 1991 2004 -3593 0 1980 2004 1994 -3594 0 1964 1988 1978 -3595 0 1964 1978 1954 -3596 0 1964 1954 1940 -3597 0 1954 1978 1967 -3598 0 1954 1967 1942 -3599 0 1942 1967 1956 -3600 0 1956 1967 1980 -3601 0 1956 1980 1970 -3602 0 1970 1980 1994 -3603 0 1940 1954 1930 -3604 0 1940 1930 1916 -3605 0 1916 1930 1906 -3606 0 1906 1930 1917 -3607 0 1917 1930 1942 -3608 0 1942 1930 1954 -3609 0 2026 2012 2036 -3610 0 1970 1994 1983 -3611 0 1983 1994 2008 -3612 0 1970 1983 1959 -3613 0 1959 1983 1971 -3614 0 1971 1983 1996 -3615 0 1996 1983 2008 -3616 0 1971 1996 1987 -3617 0 1987 1996 2011 -3618 0 1971 1987 1963 -3619 0 1963 1987 1979 -3620 0 1979 1987 2003 -3621 0 2036 2012 2025 -3622 0 2025 2012 2001 -3623 0 2025 2001 2010 -3624 0 2010 2001 1986 -3625 0 1986 2001 1977 -3626 0 1996 2008 2020 -3627 0 2011 1996 2020 -3628 0 2003 1987 2011 -3629 0 2003 2011 2027 -3630 0 2139 2148 2163 -3631 0 2163 2148 2172 -3632 0 2139 2163 2156 -3633 0 2139 2156 2133 -3634 0 2156 2163 2179 -3635 0 2172 2148 2154 -3636 0 2133 2156 2149 -3637 0 2133 2149 2127 -3638 0 2179 2163 2187 -3639 0 2187 2163 2172 -3640 0 2179 2187 2202 -3641 0 2179 2202 2197 -3642 0 2197 2202 2221 -3643 0 2221 2202 2226 -3644 0 2226 2202 2211 -3645 0 2211 2202 2187 -3646 0 2187 2172 2196 -3647 0 2187 2196 2211 -3648 0 2196 2172 2178 -3649 0 2196 2178 2203 -3650 0 2203 2178 2188 -3651 0 2188 2178 2164 -3652 0 2164 2178 2154 -3653 0 2178 2172 2154 -3654 0 2164 2154 2140 -3655 0 2211 2196 2220 -3656 0 2220 2196 2203 -3657 0 2220 2203 2227 -3658 0 2227 2203 2212 -3659 0 2212 2203 2188 -3660 0 2227 2212 2236 -3661 0 2227 2236 2251 -3662 0 2251 2236 2260 -3663 0 2236 2212 2222 -3664 0 2260 2236 2246 -3665 0 2246 2236 2222 -3666 0 2222 2212 2198 -3667 0 2198 2212 2188 -3668 0 2222 2198 2206 -3669 0 2206 2198 2182 -3670 0 2222 2206 2230 -3671 0 2230 2206 2214 -3672 0 2214 2206 2190 -3673 0 2190 2206 2182 -3674 0 2214 2190 2200 -3675 0 2214 2200 2224 -3676 0 2224 2200 2209 -3677 0 2224 2209 2233 -3678 0 2233 2209 2218 -3679 0 2233 2218 2242 -3680 0 2242 2218 2228 -3681 0 2214 2224 2237 -3682 0 2228 2218 2204 -3683 0 2228 2204 2213 -3684 0 2213 2204 2189 -3685 0 2213 2189 2201 -3686 0 2189 2204 2180 -3687 0 2237 2224 2248 -3688 0 2248 2224 2233 -3689 0 2248 2233 2257 -3690 0 2257 2233 2242 -3691 0 2257 2242 2266 -3692 0 2266 2242 2252 -3693 0 2252 2242 2228 -3694 0 2252 2228 2238 -3695 0 2238 2228 2213 -3696 0 2238 2213 2225 -3697 0 2225 2213 2201 -3698 0 2225 2201 2210 -3699 0 2210 2201 2186 -3700 0 2210 2186 2199 -3701 0 2210 2199 2223 -3702 0 2248 2257 2272 -3703 0 2272 2257 2281 -3704 0 2281 2257 2266 -3705 0 2281 2266 2291 -3706 0 2291 2266 2276 -3707 0 2276 2266 2252 -3708 0 2276 2252 2262 -3709 0 2262 2252 2238 -3710 0 2262 2238 2249 -3711 0 2249 2238 2225 -3712 0 2249 2225 2234 -3713 0 2234 2225 2210 -3714 0 2234 2210 2223 -3715 0 2234 2223 2247 -3716 0 2234 2247 2259 -3717 0 2259 2247 2271 -3718 0 2259 2271 2283 -3719 0 2271 2247 2256 -3720 0 2283 2271 2295 -3721 0 2295 2271 2280 -3722 0 2283 2295 2307 -3723 0 2283 2307 2297 -3724 0 2307 2295 2319 -3725 0 2319 2295 2304 -3726 0 2297 2307 2321 -3727 0 2321 2307 2332 -3728 0 2332 2307 2319 -3729 0 2304 2295 2280 -3730 0 2149 2156 2173 -3731 0 2173 2156 2179 -3732 0 2173 2179 2197 -3733 0 2304 2280 2293 -3734 0 2280 2271 2256 -3735 0 2304 2293 2317 -3736 0 2317 2293 2303 -3737 0 2303 2293 2279 -3738 0 2317 2303 2327 -3739 0 2327 2303 2313 -3740 0 2313 2303 2289 -3741 0 2289 2303 2279 -3742 0 2317 2327 2341 -3743 0 2341 2327 2351 -3744 0 2317 2341 2328 -3745 0 2328 2341 2352 -3746 0 2352 2341 2366 -3747 0 2366 2341 2351 -3748 0 2351 2327 2339 -3749 0 2339 2327 2313 -3750 0 2351 2339 2363 -3751 0 2351 2363 2375 -3752 0 2375 2363 2387 -3753 0 2387 2363 2374 -3754 0 2374 2363 2350 -3755 0 2350 2363 2339 -3756 0 2350 2339 2326 -3757 0 2326 2339 2313 -3758 0 2350 2326 2336 -3759 0 2336 2326 2312 -3760 0 2312 2326 2302 -3761 0 2302 2326 2313 -3762 0 2350 2336 2361 -3763 0 2350 2361 2374 -3764 0 2374 2361 2386 -3765 0 2374 2386 2398 -3766 0 2398 2386 2410 -3767 0 2410 2386 2409 -3768 0 2410 2409 2433 -3769 0 2361 2336 2360 -3770 0 2361 2360 2385 -3771 0 2304 2317 2328 -3772 0 2304 2328 2319 -3773 0 2319 2328 2343 -3774 0 2343 2328 2352 -3775 0 2343 2352 2367 -3776 0 2367 2352 2377 -3777 0 2367 2377 2391 -3778 0 2377 2352 2366 -3779 0 2377 2366 2390 -3780 0 2390 2366 2375 -3781 0 2390 2375 2399 -3782 0 2399 2375 2387 -3783 0 2391 2377 2401 -3784 0 2401 2377 2390 -3785 0 2391 2401 2415 -3786 0 2391 2415 2404 -3787 0 2415 2401 2426 -3788 0 2426 2401 2414 -3789 0 2404 2415 2428 -3790 0 2428 2415 2439 -3791 0 2439 2415 2426 -3792 0 2414 2401 2390 -3793 0 2414 2390 2399 -3794 0 2414 2399 2423 -3795 0 2423 2399 2412 -3796 0 2412 2399 2387 -3797 0 2412 2387 2398 -3798 0 2412 2398 2422 -3799 0 2422 2398 2410 -3800 0 2422 2410 2434 -3801 0 2434 2410 2433 -3802 0 2434 2433 2457 -3803 0 2398 2387 2374 -3804 0 2375 2366 2351 -3805 0 2289 2279 2265 -3806 0 1940 1916 1929 -3807 0 1940 1929 1953 -3808 0 1953 1929 1938 -3809 0 1929 1916 1903 -3810 0 1903 1916 1892 -3811 0 1938 1929 1914 -3812 0 1914 1929 1903 -3813 0 1953 1938 1962 -3814 0 1903 1892 1879 -3815 0 1879 1892 1868 -3816 0 1868 1892 1882 -3817 0 1882 1892 1906 -3818 0 1906 1892 1916 -3819 0 1962 1938 1950 -3820 0 1962 1950 1975 -3821 0 1962 1975 1986 -3822 0 1986 1975 2000 -3823 0 2000 1975 1999 -3824 0 2000 1999 2023 -3825 0 1950 1938 1926 -3826 0 1926 1938 1914 -3827 0 1975 1950 1974 -3828 0 1975 1974 1999 -3829 0 1914 1903 1890 -3830 0 1890 1903 1879 -3831 0 1890 1879 1865 -3832 0 1890 1865 1877 -3833 0 1890 1877 1901 -3834 0 1901 1877 1900 -3835 0 1901 1900 1925 -3836 0 1865 1879 1854 -3837 0 1877 1865 1853 -3838 0 1865 1854 1841 -3839 0 1841 1854 1830 -3840 0 1830 1854 1843 -3841 0 1843 1854 1868 -3842 0 1868 1854 1879 -3843 0 1853 1865 1841 -3844 0 1853 1841 1829 -3845 0 1853 1829 1852 -3846 0 1853 1852 1876 -3847 0 1829 1841 1817 -3848 0 1829 1817 1805 -3849 0 1829 1805 1828 -3850 0 1829 1828 1852 -3851 0 1805 1817 1793 -3852 0 1793 1817 1806 -3853 0 1805 1793 1781 -3854 0 1806 1817 1830 -3855 0 1830 1817 1841 -3856 0 1781 1793 1769 -3857 0 1769 1793 1782 -3858 0 1781 1769 1759 -3859 0 1781 1759 1780 -3860 0 1781 1780 1804 -3861 0 1782 1793 1806 -3862 0 1782 1806 1794 -3863 0 1794 1806 1818 -3864 0 1818 1806 1830 -3865 0 1759 1769 1746 -3866 0 1818 1830 1843 -3867 0 1818 1843 1833 -3868 0 1818 1833 1809 -3869 0 1809 1833 1821 -3870 0 1821 1833 1845 -3871 0 1845 1833 1858 -3872 0 1818 1809 1794 -3873 0 1794 1809 1783 -3874 0 1783 1809 1797 -3875 0 1833 1843 1858 -3876 0 1858 1843 1868 -3877 0 1797 1809 1821 -3878 0 1858 1868 1882 -3879 0 1797 1821 1812 -3880 0 1797 1812 1788 -3881 0 1788 1812 1800 -3882 0 1812 1821 1836 -3883 0 1800 1812 1824 -3884 0 1824 1812 1836 -3885 0 1824 1836 1848 -3886 0 1848 1836 1860 -3887 0 1836 1821 1845 -3888 0 1858 1882 1869 -3889 0 1869 1882 1893 -3890 0 1893 1882 1906 -3891 0 1860 1836 1845 -3892 0 1926 1914 1901 -3893 0 1901 1914 1890 -3894 0 1926 1901 1925 -3895 0 1926 1925 1949 -3896 0 1893 1906 1917 -3897 0 1893 1917 1908 -3898 0 1908 1917 1932 -3899 0 1932 1917 1942 -3900 0 1908 1932 1922 -3901 0 1908 1922 1898 -3902 0 1898 1922 1911 -3903 0 1898 1911 1886 -3904 0 1886 1911 1899 -3905 0 1899 1911 1923 -3906 0 1923 1911 1935 -3907 0 1911 1922 1935 -3908 0 1935 1922 1946 -3909 0 1935 1946 1959 -3910 0 1959 1946 1970 -3911 0 1923 1935 1947 -3912 0 1923 1947 1939 -3913 0 1939 1947 1963 -3914 0 1963 1947 1971 -3915 0 1971 1947 1959 -3916 0 1970 1946 1956 -3917 0 1860 1845 1869 -3918 0 1869 1845 1858 -3919 0 1956 1946 1932 -3920 0 1932 1946 1922 -3921 0 1860 1869 1884 -3922 0 1884 1869 1893 -3923 0 1884 1893 1908 -3924 0 1860 1884 1874 -3925 0 1860 1874 1848 -3926 0 1874 1884 1898 -3927 0 1898 1884 1908 -3928 0 1874 1898 1886 -3929 0 1874 1886 1862 -3930 0 1862 1886 1875 -3931 0 1862 1875 1851 -3932 0 1851 1875 1867 -3933 0 1851 1867 1844 -3934 0 1844 1867 1859 -3935 0 1875 1886 1899 -3936 0 1875 1899 1891 -3937 0 1891 1899 1915 -3938 0 1867 1875 1891 -3939 0 1859 1867 1883 -3940 0 1883 1867 1891 -3941 0 1915 1899 1923 -3942 0 1915 1923 1939 -3943 0 1915 1939 1931 -3944 0 1931 1939 1955 -3945 0 1915 1931 1907 -3946 0 1907 1931 1921 -3947 0 1907 1921 1897 -3948 0 1955 1939 1963 -3949 0 1955 1963 1979 -3950 0 1897 1921 1912 -3951 0 1912 1921 1936 -3952 0 1936 1921 1945 -3953 0 1897 1912 1888 -3954 0 1888 1912 1904 -3955 0 1904 1912 1928 -3956 0 1928 1912 1936 -3957 0 1928 1936 1952 -3958 0 1952 1936 1960 -3959 0 1945 1921 1931 -3960 0 1960 1936 1945 -3961 0 1960 1945 1969 -3962 0 1969 1945 1955 -3963 0 1960 1969 1985 -3964 0 1955 1945 1931 -3965 0 1848 1874 1862 -3966 0 1848 1862 1837 -3967 0 1837 1862 1851 -3968 0 1837 1851 1827 -3969 0 1837 1827 1813 -3970 0 1813 1827 1803 -3971 0 1803 1827 1820 -3972 0 1820 1827 1844 -3973 0 1844 1827 1851 -3974 0 1985 1969 1993 -3975 0 1985 1993 2009 -3976 0 1993 1969 1979 -3977 0 1993 1979 2003 -3978 0 1848 1837 1824 -3979 0 1824 1837 1813 -3980 0 1824 1813 1800 -3981 0 1800 1813 1789 -3982 0 1789 1813 1803 -3983 0 1789 1803 1779 -3984 0 1779 1803 1795 -3985 0 1795 1803 1820 -3986 0 1800 1789 1776 -3987 0 1800 1776 1788 -3988 0 1776 1789 1765 -3989 0 1776 1765 1751 -3990 0 1751 1765 1742 -3991 0 1742 1765 1758 -3992 0 1758 1765 1779 -3993 0 1779 1765 1789 -3994 0 1788 1776 1764 -3995 0 1764 1776 1751 -3996 0 1779 1795 1771 -3997 0 1779 1771 1758 -3998 0 1758 1771 1748 -3999 0 1748 1771 1763 -4000 0 1763 1771 1787 -4001 0 1787 1771 1795 -4002 0 1787 1795 1811 -4003 0 1787 1811 1801 -4004 0 1801 1811 1825 -4005 0 1811 1795 1820 -4006 0 1825 1811 1835 -4007 0 1825 1835 1849 -4008 0 1849 1835 1859 -4009 0 1859 1835 1844 -4010 0 1844 1835 1820 -4011 0 1835 1811 1820 -4012 0 1849 1859 1873 -4013 0 1849 1873 1864 -4014 0 1849 1864 1840 -4015 0 1840 1864 1856 -4016 0 1856 1864 1880 -4017 0 1880 1864 1888 -4018 0 1888 1864 1873 -4019 0 1888 1873 1897 -4020 0 1897 1873 1883 -4021 0 1897 1883 1907 -4022 0 1907 1883 1891 -4023 0 1873 1859 1883 -4024 0 1907 1891 1915 -4025 0 1758 1748 1736 -4026 0 1758 1736 1742 -4027 0 1742 1736 1720 -4028 0 1720 1736 1713 -4029 0 1720 1713 1700 -4030 0 1713 1736 1724 -4031 0 1713 1724 1703 -4032 0 1724 1736 1748 -4033 0 1724 1748 1739 -4034 0 1739 1748 1763 -4035 0 1724 1739 1714 -4036 0 1703 1724 1714 -4037 0 1703 1714 1684 -4038 0 1714 1739 1734 -4039 0 1714 1734 1712 -4040 0 1734 1739 1754 -4041 0 1754 1739 1763 -4042 0 1712 1734 1721 -4043 0 1721 1734 1745 -4044 0 1712 1721 1692 -4045 0 1745 1734 1754 -4046 0 1745 1754 1767 -4047 0 1767 1754 1777 -4048 0 1777 1754 1763 -4049 0 1745 1767 1761 -4050 0 1777 1763 1787 -4051 0 1700 1713 1682 -4052 0 1761 1767 1785 -4053 0 1761 1785 1774 -4054 0 1745 1761 1738 -4055 0 1745 1738 1721 -4056 0 1721 1738 1717 -4057 0 1721 1717 1692 -4058 0 1774 1785 1798 -4059 0 1798 1785 1808 -4060 0 1808 1785 1791 -4061 0 1791 1785 1767 -4062 0 1774 1798 1790 -4063 0 1790 1798 1814 -4064 0 1774 1790 1766 -4065 0 1814 1798 1822 -4066 0 1822 1798 1808 -4067 0 1822 1808 1832 -4068 0 1832 1808 1816 -4069 0 1816 1808 1791 -4070 0 1816 1791 1801 -4071 0 1766 1790 1784 -4072 0 1784 1790 1807 -4073 0 1807 1790 1814 -4074 0 1777 1787 1801 -4075 0 1777 1801 1791 -4076 0 1777 1791 1767 -4077 0 1738 1761 1750 -4078 0 1750 1761 1774 -4079 0 1738 1750 1731 -4080 0 1738 1731 1717 -4081 0 1717 1731 1699 -4082 0 1731 1750 1744 -4083 0 1731 1744 1723 -4084 0 1723 1744 1737 -4085 0 1731 1723 1699 -4086 0 1737 1744 1760 -4087 0 1737 1760 1752 -4088 0 1760 1744 1766 -4089 0 1752 1760 1775 -4090 0 1775 1760 1784 -4091 0 1750 1774 1766 -4092 0 1766 1744 1750 -4093 0 1775 1784 1799 -4094 0 1799 1784 1807 -4095 0 1775 1799 1792 -4096 0 1792 1799 1815 -4097 0 1815 1799 1823 -4098 0 1823 1799 1807 -4099 0 1792 1815 1810 -4100 0 1792 1810 1786 -4101 0 1786 1810 1802 -4102 0 1802 1810 1826 -4103 0 1826 1810 1834 -4104 0 1834 1810 1815 -4105 0 1834 1815 1839 -4106 0 1839 1815 1823 -4107 0 1834 1839 1857 -4108 0 1834 1857 1850 -4109 0 1857 1839 1863 -4110 0 1863 1839 1847 -4111 0 1847 1839 1823 -4112 0 1850 1857 1872 -4113 0 1847 1823 1831 -4114 0 1872 1857 1881 -4115 0 1881 1857 1863 -4116 0 1831 1823 1807 -4117 0 1831 1807 1814 -4118 0 1831 1814 1838 -4119 0 1838 1814 1822 -4120 0 1831 1838 1855 -4121 0 1855 1838 1861 -4122 0 1861 1838 1846 -4123 0 1846 1838 1822 -4124 0 1861 1846 1871 -4125 0 1861 1871 1885 -4126 0 1871 1846 1856 -4127 0 1885 1871 1895 -4128 0 1895 1871 1880 -4129 0 1831 1855 1847 -4130 0 1847 1855 1870 -4131 0 1847 1870 1863 -4132 0 1863 1870 1887 -4133 0 1863 1887 1881 -4134 0 1881 1887 1905 -4135 0 1881 1905 1896 -4136 0 1896 1905 1920 -4137 0 1920 1905 1927 -4138 0 1856 1846 1832 -4139 0 1880 1871 1856 -4140 0 1832 1846 1822 -4141 0 1927 1905 1910 -4142 0 1927 1910 1934 -4143 0 1910 1905 1887 -4144 0 1934 1910 1918 -4145 0 1934 1918 1941 -4146 0 1941 1918 1924 -4147 0 1941 1924 1948 -4148 0 1948 1924 1933 -4149 0 1933 1924 1909 -4150 0 1909 1924 1902 -4151 0 1902 1924 1918 -4152 0 1918 1910 1894 -4153 0 1918 1894 1902 -4154 0 1902 1894 1878 -4155 0 1902 1878 1885 -4156 0 1885 1878 1861 -4157 0 1894 1910 1887 -4158 0 1861 1878 1855 -4159 0 1855 1878 1870 -4160 0 1870 1878 1894 -4161 0 1775 1792 1768 -4162 0 1768 1792 1786 -4163 0 1768 1786 1762 -4164 0 1768 1762 1743 -4165 0 1743 1762 1740 -4166 0 1762 1786 1778 -4167 0 1778 1786 1802 -4168 0 1740 1762 1756 -4169 0 1740 1756 1722 -4170 0 1756 1762 1778 -4171 0 1756 1778 1772 -4172 0 1772 1778 1796 -4173 0 1796 1778 1802 -4174 0 1756 1772 1749 -4175 0 1756 1749 1722 -4176 0 1768 1743 1752 -4177 0 1752 1743 1732 -4178 0 1732 1743 1715 -4179 0 1768 1752 1775 -4180 0 1752 1732 1737 -4181 0 1737 1732 1706 -4182 0 1784 1760 1766 -4183 0 2260 2246 2270 -4184 0 2260 2270 2284 -4185 0 2260 2284 2275 -4186 0 2284 2270 2294 -4187 0 2270 2246 2253 -4188 0 2294 2270 2277 -4189 0 2253 2246 2230 -4190 0 2294 2277 2301 -4191 0 2301 2277 2285 -4192 0 2285 2277 2261 -4193 0 2275 2284 2299 -4194 0 2299 2284 2308 -4195 0 2308 2284 2294 -4196 0 2261 2277 2253 -4197 0 2253 2277 2270 -4198 0 2261 2253 2237 -4199 0 2230 2246 2222 -4200 0 2237 2253 2230 -4201 0 2237 2230 2214 -4202 0 2308 2294 2318 -4203 0 2308 2318 2331 -4204 0 2331 2318 2342 -4205 0 2342 2318 2325 -4206 0 2331 2342 2355 -4207 0 2355 2342 2365 -4208 0 2365 2342 2349 -4209 0 2365 2349 2373 -4210 0 2373 2349 2357 -4211 0 2357 2349 2333 -4212 0 2333 2349 2325 -4213 0 2325 2349 2342 -4214 0 2325 2318 2301 -4215 0 2301 2318 2294 -4216 0 2325 2301 2309 -4217 0 2309 2301 2285 -4218 0 2325 2309 2333 -4219 0 2333 2309 2320 -4220 0 2333 2320 2344 -4221 0 2333 2344 2357 -4222 0 2344 2320 2329 -4223 0 2344 2329 2353 -4224 0 2353 2329 2340 -4225 0 2340 2329 2316 -4226 0 2316 2329 2305 -4227 0 2305 2329 2320 -4228 0 2320 2309 2296 -4229 0 2320 2296 2305 -4230 0 2296 2309 2285 -4231 0 2305 2296 2281 -4232 0 2357 2344 2368 -4233 0 2368 2344 2353 -4234 0 2357 2368 2381 -4235 0 2381 2368 2392 -4236 0 2392 2368 2376 -4237 0 2376 2368 2353 -4238 0 2357 2381 2373 -4239 0 2373 2381 2397 -4240 0 2397 2381 2405 -4241 0 2405 2381 2392 -4242 0 2397 2405 2420 -4243 0 2420 2405 2429 -4244 0 2429 2405 2416 -4245 0 2416 2405 2392 -4246 0 2397 2420 2413 -4247 0 2397 2413 2389 -4248 0 2389 2413 2403 -4249 0 2413 2420 2437 -4250 0 2437 2420 2444 -4251 0 2444 2420 2429 -4252 0 2403 2413 2427 -4253 0 2427 2413 2437 -4254 0 2403 2427 2419 -4255 0 2419 2427 2443 -4256 0 2443 2427 2451 -4257 0 2451 2427 2437 -4258 0 2403 2419 2395 -4259 0 2395 2419 2408 -4260 0 2403 2395 2379 -4261 0 2379 2395 2371 -4262 0 2371 2395 2384 -4263 0 2384 2395 2408 -4264 0 2408 2419 2432 -4265 0 2408 2432 2425 -4266 0 2432 2419 2443 -4267 0 2425 2432 2448 -4268 0 2448 2432 2456 -4269 0 2456 2432 2443 -4270 0 2456 2443 2467 -4271 0 2467 2443 2451 -4272 0 2456 2467 2480 -4273 0 2456 2480 2472 -4274 0 2480 2467 2491 -4275 0 2491 2467 2475 -4276 0 2475 2467 2451 -4277 0 2472 2480 2496 -4278 0 2496 2480 2504 -4279 0 2504 2480 2491 -4280 0 2475 2451 2461 -4281 0 2475 2461 2485 -4282 0 2485 2461 2468 -4283 0 2468 2461 2444 -4284 0 2461 2451 2437 -4285 0 2444 2461 2437 -4286 0 2281 2296 2272 -4287 0 2272 2296 2285 -4288 0 2272 2285 2261 -4289 0 2272 2261 2248 -4290 0 2248 2261 2237 -4291 0 2331 2355 2347 -4292 0 2331 2347 2323 -4293 0 2323 2347 2338 -4294 0 2323 2338 2315 -4295 0 2323 2315 2299 -4296 0 2299 2315 2290 -4297 0 2290 2315 2306 -4298 0 2347 2355 2371 -4299 0 2371 2355 2379 -4300 0 2379 2355 2365 -4301 0 2338 2347 2362 -4302 0 2362 2347 2371 -4303 0 2362 2371 2384 -4304 0 2362 2384 2378 -4305 0 2362 2378 2354 -4306 0 2378 2384 2402 -4307 0 2354 2378 2370 -4308 0 2370 2378 2394 -4309 0 2394 2378 2402 -4310 0 2306 2315 2330 -4311 0 2330 2315 2338 -4312 0 2402 2384 2408 -4313 0 2402 2408 2425 -4314 0 2394 2402 2417 -4315 0 2394 2417 2407 -4316 0 2407 2417 2431 -4317 0 2431 2417 2441 -4318 0 2441 2417 2425 -4319 0 2425 2417 2402 -4320 0 2431 2441 2455 -4321 0 2455 2441 2465 -4322 0 2465 2441 2448 -4323 0 2465 2448 2472 -4324 0 2448 2441 2425 -4325 0 2472 2448 2456 -4326 0 2330 2338 2354 -4327 0 2330 2354 2346 -4328 0 2354 2338 2362 -4329 0 2346 2354 2370 -4330 0 2346 2370 2359 -4331 0 2346 2359 2337 -4332 0 2359 2370 2383 -4333 0 2383 2370 2394 -4334 0 2383 2394 2407 -4335 0 2330 2346 2322 -4336 0 2322 2346 2337 -4337 0 2322 2337 2314 -4338 0 2322 2314 2298 -4339 0 2298 2314 2292 -4340 0 2330 2322 2306 -4341 0 2306 2322 2298 -4342 0 2306 2298 2282 -4343 0 2282 2298 2274 -4344 0 2306 2282 2290 -4345 0 2290 2282 2267 -4346 0 2267 2282 2258 -4347 0 2274 2298 2292 -4348 0 2258 2282 2274 -4349 0 2258 2274 2250 -4350 0 2258 2250 2235 -4351 0 2250 2274 2268 -4352 0 2235 2250 2226 -4353 0 2226 2250 2245 -4354 0 2268 2274 2292 -4355 0 2245 2250 2268 -4356 0 2235 2226 2211 -4357 0 2235 2211 2220 -4358 0 2235 2220 2243 -4359 0 2235 2243 2258 -4360 0 2243 2220 2227 -4361 0 2243 2227 2251 -4362 0 2258 2243 2267 -4363 0 2267 2243 2251 -4364 0 2267 2251 2275 -4365 0 2267 2275 2290 -4366 0 2275 2251 2260 -4367 0 2290 2275 2299 -4368 0 2331 2323 2308 -4369 0 2308 2323 2299 -4370 0 2316 2305 2291 -4371 0 2316 2291 2300 -4372 0 2300 2291 2276 -4373 0 2291 2305 2281 -4374 0 2300 2276 2286 -4375 0 2286 2276 2262 -4376 0 2300 2286 2310 -4377 0 2310 2286 2297 -4378 0 2297 2286 2273 -4379 0 2297 2273 2283 -4380 0 2283 2273 2259 -4381 0 2273 2286 2262 -4382 0 2273 2262 2249 -4383 0 2273 2249 2259 -4384 0 2259 2249 2234 -4385 0 2300 2310 2324 -4386 0 2300 2324 2316 -4387 0 2324 2310 2334 -4388 0 2324 2334 2348 -4389 0 2348 2334 2358 -4390 0 2358 2334 2345 -4391 0 2345 2334 2321 -4392 0 2321 2334 2310 -4393 0 2321 2310 2297 -4394 0 2348 2358 2372 -4395 0 2348 2372 2364 -4396 0 2348 2364 2340 -4397 0 2364 2372 2388 -4398 0 2388 2372 2396 -4399 0 2388 2396 2411 -4400 0 2411 2396 2421 -4401 0 2421 2396 2406 -4402 0 2406 2396 2382 -4403 0 2382 2396 2372 -4404 0 2340 2364 2353 -4405 0 2316 2324 2340 -4406 0 2340 2324 2348 -4407 0 2353 2364 2376 -4408 0 2376 2364 2388 -4409 0 2376 2388 2400 -4410 0 2376 2400 2392 -4411 0 2400 2388 2411 -4412 0 2392 2400 2416 -4413 0 2416 2400 2424 -4414 0 2424 2400 2411 -4415 0 2424 2411 2435 -4416 0 2435 2411 2421 -4417 0 2435 2421 2445 -4418 0 2445 2421 2430 -4419 0 2430 2421 2406 -4420 0 2445 2430 2454 -4421 0 2445 2454 2469 -4422 0 2469 2454 2478 -4423 0 2478 2454 2466 -4424 0 2466 2454 2442 -4425 0 2466 2442 2452 -4426 0 2452 2442 2428 -4427 0 2428 2442 2418 -4428 0 2418 2442 2430 -4429 0 2442 2454 2430 -4430 0 2372 2358 2382 -4431 0 2382 2358 2369 -4432 0 2382 2369 2393 -4433 0 2393 2369 2380 -4434 0 2382 2393 2406 -4435 0 2380 2369 2356 -4436 0 2380 2356 2367 -4437 0 2367 2356 2343 -4438 0 2343 2356 2332 -4439 0 2406 2393 2418 -4440 0 2369 2358 2345 -4441 0 2418 2393 2404 -4442 0 2404 2393 2380 -4443 0 2418 2404 2428 -4444 0 2343 2332 2319 -4445 0 2356 2369 2345 -4446 0 2356 2345 2332 -4447 0 2332 2345 2321 -4448 0 2404 2380 2391 -4449 0 2391 2380 2367 -4450 0 1856 1832 1840 -4451 0 1840 1832 1816 -4452 0 1840 1816 1825 -4453 0 1825 1816 1801 -4454 0 1840 1825 1849 -4455 0 2335 2360 2336 -4456 0 2335 2336 2312 -4457 0 1797 1788 1773 -4458 0 1797 1773 1783 -4459 0 1773 1788 1764 -4460 0 1783 1773 1755 -4461 0 1773 1764 1747 -4462 0 1773 1747 1755 -4463 0 1747 1764 1741 -4464 0 1741 1764 1751 -4465 0 1747 1741 1727 -4466 0 1727 1741 1719 -4467 0 1719 1741 1733 -4468 0 1733 1741 1751 -4469 0 1733 1751 1742 -4470 0 1733 1742 1720 -4471 0 1733 1720 1710 -4472 0 1733 1710 1719 -4473 0 1710 1720 1700 -4474 0 1719 1710 1697 -4475 0 1697 1710 1677 -4476 0 1719 1697 1704 -4477 0 1719 1704 1727 -4478 0 1704 1697 1673 -4479 0 1727 1704 1729 -4480 0 1990 1982 1966 -4481 0 1990 1966 1976 -4482 0 1966 1982 1957 -4483 0 1966 1957 1943 -4484 0 1943 1957 1933 -4485 0 1966 1943 1952 -4486 0 1976 1966 1952 -4487 0 1943 1933 1919 -4488 0 1919 1933 1909 -4489 0 1943 1919 1928 -4490 0 1919 1909 1895 -4491 0 1895 1909 1885 -4492 0 1885 1909 1902 -4493 0 1976 1952 1960 -4494 0 1928 1919 1904 -4495 0 1976 1960 1985 -4496 0 1904 1919 1895 -4497 0 1933 1957 1948 -4498 0 1952 1943 1928 -4499 0 1746 1730 1759 -4500 0 2479 2455 2465 -4501 0 2479 2465 2489 -4502 0 2489 2465 2472 -4503 0 2489 2472 2496 -4504 0 2489 2496 2513 -4505 0 2513 2496 2520 -4506 0 2489 2513 2503 -4507 0 2503 2513 2527 -4508 0 2527 2513 2537 -4509 0 2537 2513 2520 -4510 0 2520 2496 2504 -4511 0 2520 2504 2528 -4512 0 2520 2528 2543 -4513 0 2528 2504 2514 -4514 0 2520 2543 2537 -4515 0 2537 2543 2561 -4516 0 2561 2543 2567 -4517 0 2567 2543 2552 -4518 0 2552 2543 2528 -4519 0 2479 2489 2503 -4520 0 2514 2504 2491 -4521 0 2514 2491 2499 -4522 0 2499 2491 2475 -4523 0 2499 2475 2485 -4524 0 2499 2485 2508 -4525 0 2499 2508 2523 -4526 0 2508 2485 2492 -4527 0 2523 2508 2532 -4528 0 2532 2508 2516 -4529 0 2492 2485 2468 -4530 0 2516 2508 2492 -4531 0 2516 2492 2501 -4532 0 2501 2492 2477 -4533 0 2501 2477 2488 -4534 0 2477 2492 2468 -4535 0 2488 2477 2464 -4536 0 2488 2464 2473 -4537 0 2473 2464 2449 -4538 0 2449 2464 2440 -4539 0 2440 2464 2453 -4540 0 2449 2440 2424 -4541 0 2453 2464 2477 -4542 0 2552 2528 2538 -4543 0 2538 2528 2514 -4544 0 2552 2538 2562 -4545 0 2562 2538 2547 -4546 0 2552 2562 2576 -4547 0 2576 2562 2586 -4548 0 2586 2562 2570 -4549 0 2570 2562 2547 -4550 0 2547 2538 2523 -4551 0 2523 2538 2514 -4552 0 2453 2477 2468 -4553 0 2453 2468 2444 -4554 0 2453 2444 2429 -4555 0 2424 2440 2416 -4556 0 2453 2429 2440 -4557 0 2547 2523 2532 -4558 0 2416 2440 2429 -4559 0 2561 2567 2584 -4560 0 2561 2584 2574 -4561 0 2574 2584 2598 -4562 0 2598 2584 2607 -4563 0 2561 2574 2551 -4564 0 2561 2551 2537 -4565 0 2598 2607 2622 -4566 0 2584 2567 2591 -4567 0 2591 2567 2576 -4568 0 2576 2567 2552 -4569 0 2537 2551 2527 -4570 0 2622 2607 2631 -4571 0 2631 2607 2614 -4572 0 2614 2607 2591 -4573 0 2591 2607 2584 -4574 0 2614 2591 2600 -4575 0 2600 2591 2576 -4576 0 2631 2614 2638 -4577 0 2638 2614 2624 -4578 0 2631 2638 2655 -4579 0 2655 2638 2662 -4580 0 2662 2638 2648 -4581 0 2648 2638 2624 -4582 0 2631 2655 2646 -4583 0 2624 2614 2600 -4584 0 2622 2631 2646 -4585 0 2646 2655 2670 -4586 0 2670 2655 2679 -4587 0 2670 2679 2694 -4588 0 2679 2655 2662 -4589 0 2694 2679 2703 -4590 0 2703 2679 2686 -4591 0 2686 2679 2662 -4592 0 2703 2686 2710 -4593 0 2710 2686 2695 -4594 0 2695 2686 2672 -4595 0 2695 2672 2682 -4596 0 2682 2672 2658 -4597 0 2672 2686 2662 -4598 0 2658 2672 2648 -4599 0 2703 2710 2727 -4600 0 2727 2710 2734 -4601 0 2734 2710 2719 -4602 0 2719 2710 2695 -4603 0 2719 2695 2706 -4604 0 2706 2695 2682 -4605 0 2706 2682 2690 -4606 0 2690 2682 2666 -4607 0 2666 2682 2658 -4608 0 2666 2658 2642 -4609 0 2642 2658 2634 -4610 0 2634 2658 2648 -4611 0 2634 2648 2624 -4612 0 2672 2662 2648 -4613 0 2634 2624 2610 -4614 0 2634 2610 2618 -4615 0 2618 2610 2594 -4616 0 2594 2610 2586 -4617 0 2586 2610 2600 -4618 0 2634 2618 2642 -4619 0 2642 2618 2625 -4620 0 2625 2618 2601 -4621 0 2601 2618 2594 -4622 0 2610 2624 2600 -4623 0 2594 2586 2570 -4624 0 2594 2570 2579 -4625 0 2594 2579 2601 -4626 0 2579 2570 2556 -4627 0 2579 2556 2564 -4628 0 2579 2564 2588 -4629 0 2588 2564 2573 -4630 0 2573 2564 2549 -4631 0 2549 2564 2540 -4632 0 2540 2564 2556 -4633 0 2540 2556 2532 -4634 0 2540 2532 2516 -4635 0 2540 2516 2525 -4636 0 2532 2556 2547 -4637 0 2547 2556 2570 -4638 0 2525 2516 2501 -4639 0 2525 2501 2512 -4640 0 2525 2512 2536 -4641 0 2512 2501 2488 -4642 0 2525 2536 2549 -4643 0 2525 2549 2540 -4644 0 2549 2536 2560 -4645 0 2549 2560 2573 -4646 0 2573 2560 2585 -4647 0 2585 2560 2569 -4648 0 2560 2536 2545 -4649 0 2569 2560 2545 -4650 0 2569 2545 2555 -4651 0 2555 2545 2531 -4652 0 2531 2545 2521 -4653 0 2545 2536 2521 -4654 0 2521 2536 2512 -4655 0 2521 2512 2497 -4656 0 2497 2512 2488 -4657 0 2521 2497 2507 -4658 0 2507 2497 2483 -4659 0 2483 2497 2473 -4660 0 2507 2483 2493 -4661 0 2493 2483 2469 -4662 0 2469 2483 2459 -4663 0 2459 2483 2473 -4664 0 2601 2579 2588 -4665 0 2601 2588 2612 -4666 0 2601 2612 2625 -4667 0 2612 2588 2597 -4668 0 2597 2588 2573 -4669 0 2597 2573 2585 -4670 0 2597 2585 2609 -4671 0 2609 2585 2593 -4672 0 2593 2585 2569 -4673 0 2593 2569 2577 -4674 0 2577 2569 2555 -4675 0 2577 2555 2565 -4676 0 2565 2555 2541 -4677 0 2541 2555 2531 -4678 0 2497 2488 2473 -4679 0 2625 2612 2636 -4680 0 2636 2612 2621 -4681 0 2621 2612 2597 -4682 0 2636 2621 2645 -4683 0 2636 2645 2660 -4684 0 2660 2645 2669 -4685 0 2669 2645 2656 -4686 0 2656 2645 2632 -4687 0 2632 2645 2621 -4688 0 2632 2621 2609 -4689 0 2609 2621 2597 -4690 0 2625 2636 2649 -4691 0 2649 2636 2660 -4692 0 2649 2660 2673 -4693 0 2649 2673 2666 -4694 0 2673 2660 2684 -4695 0 2684 2660 2669 -4696 0 2625 2649 2642 -4697 0 2632 2609 2617 -4698 0 2617 2609 2593 -4699 0 2617 2593 2602 -4700 0 2617 2602 2626 -4701 0 2602 2593 2577 -4702 0 2626 2602 2613 -4703 0 2626 2613 2637 -4704 0 2613 2602 2589 -4705 0 2589 2602 2577 -4706 0 2637 2613 2623 -4707 0 2623 2613 2599 -4708 0 2599 2613 2589 -4709 0 2637 2623 2647 -4710 0 2647 2623 2635 -4711 0 2647 2635 2659 -4712 0 2659 2635 2644 -4713 0 2644 2635 2620 -4714 0 2620 2635 2611 -4715 0 2611 2635 2623 -4716 0 2599 2589 2575 -4717 0 2599 2575 2587 -4718 0 2587 2575 2563 -4719 0 2563 2575 2550 -4720 0 2550 2575 2565 -4721 0 2565 2575 2589 -4722 0 2565 2589 2577 -4723 0 2666 2673 2690 -4724 0 2690 2673 2697 -4725 0 2690 2697 2714 -4726 0 2714 2697 2721 -4727 0 2714 2721 2738 -4728 0 2738 2721 2745 -4729 0 2745 2721 2732 -4730 0 2732 2721 2708 -4731 0 2708 2721 2697 -4732 0 2708 2697 2684 -4733 0 2697 2673 2684 -4734 0 2708 2684 2693 -4735 0 2708 2693 2717 -4736 0 2717 2693 2704 -4737 0 2717 2704 2728 -4738 0 2728 2704 2713 -4739 0 2713 2704 2689 -4740 0 2689 2704 2680 -4741 0 2680 2704 2693 -4742 0 2680 2693 2669 -4743 0 2693 2684 2669 -4744 0 2680 2669 2656 -4745 0 2680 2656 2665 -4746 0 2680 2665 2689 -4747 0 2665 2656 2641 -4748 0 2641 2656 2632 -4749 0 2641 2632 2617 -4750 0 2641 2617 2626 -4751 0 2641 2626 2650 -4752 0 2650 2626 2637 -4753 0 2650 2637 2661 -4754 0 2661 2637 2647 -4755 0 2661 2647 2671 -4756 0 2671 2647 2659 -4757 0 2671 2659 2683 -4758 0 2661 2671 2685 -4759 0 2683 2659 2668 -4760 0 2685 2671 2696 -4761 0 2668 2659 2644 -4762 0 2696 2671 2683 -4763 0 2696 2683 2707 -4764 0 2707 2683 2692 -4765 0 2692 2683 2668 -4766 0 2707 2692 2716 -4767 0 2707 2716 2731 -4768 0 2716 2692 2705 -4769 0 2731 2716 2740 -4770 0 2705 2692 2681 -4771 0 2740 2716 2729 -4772 0 2729 2716 2705 -4773 0 2681 2692 2668 -4774 0 2681 2668 2657 -4775 0 2657 2668 2644 -4776 0 2681 2657 2667 -4777 0 2667 2657 2643 -4778 0 2643 2657 2633 -4779 0 2633 2657 2644 -4780 0 2681 2667 2691 -4781 0 2691 2667 2678 -4782 0 2678 2667 2654 -4783 0 2654 2667 2643 -4784 0 2633 2644 2620 -4785 0 2633 2620 2608 -4786 0 2608 2620 2596 -4787 0 2596 2620 2611 -4788 0 2596 2611 2587 -4789 0 2608 2596 2583 -4790 0 2583 2596 2572 -4791 0 2587 2611 2599 -4792 0 2599 2611 2623 -4793 0 2572 2596 2587 -4794 0 2572 2587 2563 -4795 0 2572 2563 2548 -4796 0 2548 2563 2539 -4797 0 2539 2563 2550 -4798 0 2548 2539 2524 -4799 0 2548 2524 2535 -4800 0 2524 2539 2515 -4801 0 2515 2539 2526 -4802 0 2535 2524 2511 -4803 0 2511 2524 2500 -4804 0 2500 2524 2515 -4805 0 2526 2539 2550 -4806 0 2500 2515 2490 -4807 0 2490 2515 2502 -4808 0 2502 2515 2526 -4809 0 2502 2526 2517 -4810 0 2517 2526 2541 -4811 0 2526 2550 2541 -4812 0 2541 2550 2565 -4813 0 2689 2665 2674 -4814 0 2674 2665 2650 -4815 0 2689 2674 2698 -4816 0 2698 2674 2685 -4817 0 2685 2674 2661 -4818 0 2650 2665 2641 -4819 0 2674 2650 2661 -4820 0 2572 2548 2559 -4821 0 2559 2548 2535 -4822 0 2572 2559 2583 -4823 0 2583 2559 2571 -4824 0 2571 2559 2546 -4825 0 2546 2559 2535 -4826 0 2546 2535 2522 -4827 0 2522 2535 2511 -4828 0 2546 2522 2534 -4829 0 2546 2534 2558 -4830 0 2534 2522 2510 -4831 0 2558 2534 2544 -4832 0 2510 2522 2498 -4833 0 2544 2534 2519 -4834 0 2498 2522 2511 -4835 0 2519 2534 2510 -4836 0 2519 2510 2495 -4837 0 2495 2510 2486 -4838 0 2486 2510 2498 -4839 0 2486 2498 2474 -4840 0 2474 2498 2487 -4841 0 2487 2498 2511 -4842 0 2474 2487 2463 -4843 0 2463 2487 2476 -4844 0 2476 2487 2500 -4845 0 2474 2463 2450 -4846 0 2450 2463 2439 -4847 0 2439 2463 2452 -4848 0 2452 2463 2476 -4849 0 2452 2476 2466 -4850 0 2466 2476 2490 -4851 0 2466 2490 2478 -4852 0 2478 2490 2502 -4853 0 2487 2511 2500 -4854 0 2571 2546 2558 -4855 0 2571 2558 2582 -4856 0 2571 2582 2595 -4857 0 2582 2558 2568 -4858 0 2568 2558 2544 -4859 0 2568 2544 2557 -4860 0 2557 2544 2533 -4861 0 2595 2582 2606 -4862 0 2533 2544 2519 -4863 0 2533 2519 2509 -4864 0 2509 2519 2495 -4865 0 2509 2495 2484 -4866 0 2484 2495 2471 -4867 0 2471 2495 2486 -4868 0 2484 2471 2460 -4869 0 2606 2582 2592 -4870 0 2484 2460 2470 -4871 0 2460 2471 2447 -4872 0 2470 2460 2446 -4873 0 2592 2582 2568 -4874 0 2447 2471 2462 -4875 0 2446 2460 2436 -4876 0 2436 2460 2447 -4877 0 2447 2462 2438 -4878 0 2438 2462 2450 -4879 0 2450 2462 2474 -4880 0 2474 2462 2486 -4881 0 2462 2471 2486 -4882 0 2436 2447 2423 -4883 0 2423 2447 2438 -4884 0 2436 2423 2412 -4885 0 2436 2412 2422 -4886 0 2436 2422 2446 -4887 0 2446 2422 2434 -4888 0 2446 2434 2458 -4889 0 2423 2438 2414 -4890 0 2414 2438 2426 -4891 0 2426 2438 2450 -4892 0 2426 2450 2439 -4893 0 2458 2434 2457 -4894 0 2458 2457 2481 -4895 0 2571 2595 2583 -4896 0 2583 2595 2608 -4897 0 2608 2595 2619 -4898 0 2608 2619 2633 -4899 0 2633 2619 2643 -4900 0 2643 2619 2630 -4901 0 2619 2595 2606 -4902 0 2619 2606 2630 -4903 0 2630 2606 2616 -4904 0 2616 2606 2592 -4905 0 2616 2592 2605 -4906 0 2605 2592 2581 -4907 0 2630 2616 2640 -4908 0 2581 2592 2568 -4909 0 2581 2568 2557 -4910 0 2640 2616 2629 -4911 0 2629 2616 2605 -4912 0 2640 2629 2653 -4913 0 2640 2653 2664 -4914 0 2653 2629 2639 -4915 0 2664 2653 2677 -4916 0 2639 2629 2615 -4917 0 2677 2653 2663 -4918 0 2615 2629 2605 -4919 0 2615 2605 2590 -4920 0 2590 2605 2581 -4921 0 2590 2581 2566 -4922 0 2566 2581 2557 -4923 0 2566 2557 2542 -4924 0 2542 2557 2533 -4925 0 2663 2653 2639 -4926 0 2663 2639 2652 -4927 0 2652 2639 2628 -4928 0 2628 2639 2615 -4929 0 2652 2628 2627 -4930 0 2627 2628 2603 -4931 0 2628 2615 2604 -4932 0 2628 2604 2603 -4933 0 2603 2604 2578 -4934 0 2604 2615 2590 -4935 0 2604 2590 2580 -4936 0 2604 2580 2578 -4937 0 2578 2580 2553 -4938 0 2580 2590 2566 -4939 0 2580 2566 2554 -4940 0 2554 2566 2542 -4941 0 2554 2542 2530 -4942 0 2530 2542 2518 -4943 0 2518 2542 2533 -4944 0 2580 2554 2553 -4945 0 2553 2554 2529 -4946 0 2530 2518 2506 -4947 0 2506 2518 2494 -4948 0 2530 2506 2505 -4949 0 2505 2506 2481 -4950 0 2494 2518 2509 -4951 0 2509 2518 2533 -4952 0 2494 2509 2484 -4953 0 2494 2484 2470 -4954 0 2494 2470 2482 -4955 0 2482 2470 2458 -4956 0 2458 2470 2446 -4957 0 2482 2458 2481 -4958 0 2482 2481 2506 -4959 0 2482 2506 2494 -4960 0 2642 2649 2666 -4961 0 2514 2499 2523 -4962 0 2690 2714 2706 -4963 0 2706 2714 2730 -4964 0 2730 2714 2738 -4965 0 2730 2738 2753 -4966 0 2730 2753 2743 -4967 0 2753 2738 2761 -4968 0 2730 2743 2719 -4969 0 2719 2743 2734 -4970 0 2734 2743 2758 -4971 0 2758 2743 2766 -4972 0 2766 2743 2753 -4973 0 2766 2753 2776 -4974 0 2776 2753 2761 -4975 0 2776 2761 2782 -4976 0 2782 2761 2778 -4977 0 2776 2782 2802 -4978 0 2802 2782 2799 -4979 0 2706 2730 2719 -4980 0 2766 2776 2789 -4981 0 2789 2776 2802 -4982 0 2766 2789 2781 -4983 0 2781 2789 2803 -4984 0 2766 2781 2758 -4985 0 2758 2781 2773 -4986 0 2758 2773 2750 -4987 0 2750 2773 2765 -4988 0 2765 2773 2785 -4989 0 2781 2803 2795 -4990 0 2803 2789 2815 -4991 0 2815 2789 2802 -4992 0 2795 2803 2817 -4993 0 2795 2817 2807 -4994 0 2807 2817 2828 -4995 0 2828 2817 2835 -4996 0 2817 2803 2824 -4997 0 2817 2824 2835 -4998 0 2824 2803 2815 -4999 0 2824 2815 2834 -5000 0 2785 2773 2795 -5001 0 2785 2795 2807 -5002 0 2795 2773 2781 -5003 0 2734 2758 2750 -5004 0 2734 2750 2727 -5005 0 2727 2750 2741 -5006 0 2727 2741 2718 -5007 0 2727 2718 2703 -5008 0 2703 2718 2694 -5009 0 2761 2738 2745 -5010 0 2761 2745 2778 -5011 0 2750 2765 2741 -5012 0 2507 2493 2517 -5013 0 2517 2493 2502 -5014 0 2502 2493 2478 -5015 0 2507 2517 2531 -5016 0 2507 2531 2521 -5017 0 2531 2517 2541 -5018 0 2478 2493 2469 -5019 0 2705 2681 2691 -5020 0 2705 2691 2715 -5021 0 2715 2691 2702 -5022 0 2702 2691 2678 -5023 0 2715 2702 2726 -5024 0 2726 2702 2712 -5025 0 2726 2712 2737 -5026 0 2737 2712 2725 -5027 0 2737 2725 2749 -5028 0 2749 2725 2735 -5029 0 2735 2725 2711 -5030 0 2711 2725 2701 -5031 0 2701 2725 2712 -5032 0 2701 2712 2688 -5033 0 2688 2712 2702 -5034 0 2688 2702 2678 -5035 0 2705 2715 2729 -5036 0 2688 2678 2664 -5037 0 2729 2715 2739 -5038 0 2739 2715 2726 -5039 0 2664 2678 2654 -5040 0 2664 2654 2640 -5041 0 2640 2654 2630 -5042 0 2630 2654 2643 -5043 0 2688 2664 2677 -5044 0 2688 2677 2701 -5045 0 2701 2677 2687 -5046 0 2701 2687 2711 -5047 0 2711 2687 2700 -5048 0 2711 2700 2724 -5049 0 2724 2700 2699 -5050 0 2699 2700 2675 -5051 0 2700 2687 2676 -5052 0 2676 2687 2663 -5053 0 2700 2676 2675 -5054 0 2675 2676 2651 -5055 0 2687 2677 2663 -5056 0 2749 2735 2759 -5057 0 2759 2735 2748 -5058 0 2749 2759 2772 -5059 0 2749 2772 2762 -5060 0 2772 2759 2784 -5061 0 2784 2759 2771 -5062 0 2771 2759 2748 -5063 0 2771 2748 2747 -5064 0 2747 2748 2723 -5065 0 2762 2772 2788 -5066 0 2762 2788 2774 -5067 0 2788 2772 2794 -5068 0 2794 2772 2784 -5069 0 2762 2774 2751 -5070 0 2751 2774 2763 -5071 0 2762 2751 2737 -5072 0 2763 2774 2786 -5073 0 2786 2774 2797 -5074 0 2797 2774 2788 -5075 0 2748 2735 2724 -5076 0 2748 2724 2723 -5077 0 2723 2724 2699 -5078 0 2724 2735 2711 -5079 0 2797 2788 2814 -5080 0 2737 2751 2726 -5081 0 2726 2751 2739 -5082 0 2739 2751 2763 -5083 0 2739 2763 2752 -5084 0 2739 2752 2729 -5085 0 2729 2752 2740 -5086 0 2752 2763 2775 -5087 0 2775 2763 2786 -5088 0 2775 2786 2798 -5089 0 2775 2798 2787 -5090 0 2798 2786 2816 -5091 0 2787 2798 2820 -5092 0 2740 2752 2764 -5093 0 2740 2764 2755 -5094 0 2755 2764 2777 -5095 0 2777 2764 2787 -5096 0 2787 2764 2775 -5097 0 2740 2755 2731 -5098 0 2777 2787 2800 -5099 0 2800 2787 2820 -5100 0 2777 2800 2790 -5101 0 2790 2800 2822 -5102 0 2777 2790 2767 -5103 0 2767 2790 2780 -5104 0 2777 2767 2755 -5105 0 2780 2790 2804 -5106 0 2780 2804 2801 -5107 0 2801 2804 2825 -5108 0 2764 2752 2775 -5109 0 2755 2767 2744 -5110 0 2755 2744 2731 -5111 0 2744 2767 2757 -5112 0 2757 2767 2780 -5113 0 2757 2780 2768 -5114 0 2768 2780 2801 -5115 0 2757 2768 2746 -5116 0 2746 2768 2760 -5117 0 2760 2768 2783 -5118 0 2783 2768 2801 -5119 0 2746 2760 2736 -5120 0 2736 2760 2754 -5121 0 2746 2736 2722 -5122 0 2722 2736 2713 -5123 0 2713 2736 2728 -5124 0 2754 2760 2779 -5125 0 2779 2760 2783 -5126 0 2783 2801 2806 -5127 0 2783 2806 2805 -5128 0 2806 2801 2826 -5129 0 2731 2744 2720 -5130 0 2731 2720 2707 -5131 0 2720 2744 2733 -5132 0 2733 2744 2757 -5133 0 2733 2757 2746 -5134 0 2733 2746 2722 -5135 0 2733 2722 2709 -5136 0 2709 2722 2698 -5137 0 2698 2722 2713 -5138 0 2709 2698 2685 -5139 0 2707 2720 2696 -5140 0 2696 2720 2709 -5141 0 2709 2720 2733 -5142 0 2709 2685 2696 -5143 0 2698 2713 2689 -5144 0 2728 2736 2754 -5145 0 2728 2754 2742 -5146 0 2728 2742 2717 -5147 0 2742 2754 2769 -5148 0 2717 2742 2732 -5149 0 2717 2732 2708 -5150 0 2732 2742 2756 -5151 0 2756 2742 2769 -5152 0 2732 2756 2745 -5153 0 2745 2756 2778 -5154 0 2754 2779 2769 -5155 0 2794 2784 2812 -5156 0 1949 1974 1950 -5157 0 1949 1950 1926 -5158 0 2123 2098 2110 -5159 0 2123 2110 2135 -5160 0 2135 2110 2121 -5161 0 2121 2110 2097 -5162 0 2135 2121 2145 -5163 0 2135 2145 2159 -5164 0 2145 2121 2132 -5165 0 2145 2132 2157 -5166 0 2157 2132 2144 -5167 0 2157 2144 2168 -5168 0 2168 2144 2167 -5169 0 2168 2167 2191 -5170 0 2132 2121 2107 -5171 0 2107 2121 2097 -5172 0 2107 2097 2083 -5173 0 2083 2097 2073 -5174 0 2132 2107 2120 -5175 0 2120 2107 2096 -5176 0 2096 2107 2083 -5177 0 2096 2083 2072 -5178 0 2096 2072 2095 -5179 0 2096 2095 2119 -5180 0 2072 2083 2058 -5181 0 2072 2058 2048 -5182 0 2048 2058 2034 -5183 0 2034 2058 2049 -5184 0 2049 2058 2073 -5185 0 2073 2058 2083 -5186 0 2132 2120 2144 -5187 0 2144 2120 2143 -5188 0 2144 2143 2167 -5189 0 2159 2145 2169 -5190 0 2169 2145 2157 -5191 0 2159 2169 2183 -5192 0 2169 2157 2181 -5193 0 2169 2181 2193 -5194 0 2169 2193 2183 -5195 0 2193 2181 2205 -5196 0 2193 2205 2217 -5197 0 2205 2181 2192 -5198 0 2193 2217 2207 -5199 0 2192 2181 2168 -5200 0 2181 2157 2168 -5201 0 2207 2217 2231 -5202 0 2231 2217 2241 -5203 0 2241 2217 2229 -5204 0 2241 2229 2254 -5205 0 2254 2229 2240 -5206 0 2241 2254 2265 -5207 0 2265 2254 2278 -5208 0 2278 2254 2264 -5209 0 2264 2254 2240 -5210 0 2240 2229 2216 -5211 0 2216 2229 2205 -5212 0 2240 2216 2239 -5213 0 2240 2239 2263 -5214 0 2229 2217 2205 -5215 0 2205 2192 2216 -5216 0 2216 2192 2215 -5217 0 2216 2215 2239 -5218 0 2183 2193 2207 -5219 0 2265 2278 2289 -5220 0 2289 2278 2302 -5221 0 2289 2302 2313 -5222 0 2302 2278 2288 -5223 0 2302 2288 2312 -5224 0 2288 2278 2264 -5225 0 2288 2264 2287 -5226 0 2288 2287 2311 -5227 0 2312 2288 2311 -5228 0 2312 2311 2335 -5229 0 2048 2034 2024 -5230 0 2048 2024 2047 -5231 0 2048 2047 2071 -5232 0 2024 2034 2010 -5233 0 2024 2010 2000 -5234 0 2000 2010 1986 -5235 0 2024 2000 2023 -5236 0 2024 2023 2047 -5237 0 2010 2034 2025 -5238 0 2025 2034 2049 -5239 0 2025 2049 2036 -5240 0 2036 2049 2061 -5241 0 2061 2049 2073 -5242 0 2418 2430 2406 -5243 0 1728 1722 1749 -5244 0 1671 1694 1673 -5245 0 1673 1694 1704 -5246 0 1757 1780 1759 -5247 0 1757 1759 1735 -5248 0 1913 1889 1896 -5249 0 1896 1889 1872 -5250 0 1896 1872 1881 -5251 0 1913 1896 1920 -5252 0 1913 1920 1937 -5253 0 1937 1920 1944 -5254 0 1937 1944 1961 -5255 0 1961 1944 1968 -5256 0 1961 1968 1984 -5257 0 1984 1968 1992 -5258 0 1992 1968 1973 -5259 0 1984 1992 2007 -5260 0 2007 1992 2015 -5261 0 2007 2015 2031 -5262 0 1944 1920 1927 -5263 0 1872 1889 1866 -5264 0 1872 1866 1850 -5265 0 1850 1866 1842 -5266 0 1850 1842 1826 -5267 0 1850 1826 1834 -5268 0 1826 1842 1819 -5269 0 1826 1819 1802 -5270 0 1802 1819 1796 -5271 0 2100 2084 2108 -5272 0 1964 1940 1953 -5273 0 1964 1953 1977 -5274 0 1977 1953 1962 -5275 0 1977 1962 1986 -5276 0 1947 1935 1959 -5277 0 2814 2816 2797 -5278 0 1692 1688 1712 -5279 0 1888 1904 1880 -5280 0 1880 1904 1895 -5281 0 2832 2833 2823 -5282 0 2823 2833 2815 -5283 0 2373 2397 2389 -5284 0 2373 2389 2365 -5285 0 2365 2389 2379 -5286 0 2379 2389 2403 -5287 0 1665 1693 1666 -5288 0 1723 1737 1706 -5289 0 2100 2115 2091 -5290 0 2091 2115 2109 -5291 0 2109 2115 2133 -5292 0 2133 2115 2139 -5293 0 2109 2133 2127 -5294 0 2109 2127 2103 -5295 0 1706 1702 1723 -5296 0 2500 2490 2476 -5297 0 2809 2810 2792 -5298 0 1782 1794 1770 -5299 0 1770 1794 1783 -5300 0 1782 1770 1753 -5301 0 1770 1783 1755 -5302 0 1711 1729 1704 -5303 0 1727 1729 1747 -5304 0 1965 1941 1948 -5305 0 2627 2651 2652 -5306 0 2652 2651 2676 -5307 0 2652 2676 2663 -5308 0 1680 1677 1700 -5309 0 2821 2822 2800 -5310 0 1969 1955 1979 -5311 0 2072 2048 2071 -5312 0 2072 2071 2095 -5313 0 1668 1666 1689 -5314 0 1689 1666 1693 -5315 0 2737 2749 2762 -5316 0 2385 2409 2386 -5317 0 2385 2386 2361 -5318 0 2424 2435 2449 -5319 0 2449 2435 2459 -5320 0 2449 2459 2473 -5321 0 2459 2435 2445 -5322 0 2459 2445 2469 -5323 0 2120 2096 2119 -5324 0 2120 2119 2143 -5325 0 2791 2769 2779 -5326 0 1718 1715 1740 -5327 0 2770 2792 2771 -5328 0 2770 2771 2747 -5329 0 1694 1711 1704 -5330 0 1804 1828 1805 -5331 0 1804 1805 1781 -5332 0 2245 2221 2226 -5333 0 2191 2215 2192 -5334 0 2191 2192 2168 -5335 0 1710 1700 1677 -5336 0 1684 1682 1703 -5337 0 2819 2820 2798 -5338 0 2834 2835 2824 -5339 0 2804 2790 2822 -5340 0 1716 1735 1705 -5341 0 1887 1870 1894 -5342 0 2452 2428 2439 -5343 0 1956 1932 1942 -5344 0 1699 1696 1717 -5345 0 2812 2813 2794 -5346 0 1729 1755 1747 -5347 0 1877 1853 1876 -5348 0 1877 1876 1900 -5349 0 2118 2111 2094 -5350 0 2825 2826 2801 -5351 0 1675 1673 1697 -5352 0 2778 2799 2782 -5353 0 2802 2823 2815 -5354 0 1722 1718 1740 -5355 0 2805 2779 2783 -5356 0 2816 2819 2798 -5357 0 1688 1684 1714 -5358 0 1769 1782 1753 -5359 0 2833 2834 2815 -5360 0 1693 1716 1705 -5361 0 1743 1740 1715 -5362 0 1702 1699 1723 -5363 0 2576 2586 2600 -5364 0 2810 2812 2793 -5365 0 2264 2240 2263 -5366 0 2264 2263 2287 -5367 0 1677 1675 1697 -5368 0 2822 2825 2804 -5369 0 1713 1703 1682 -5370 0 2786 2797 2816 -5371 0 2769 2778 2756 -5372 0 1715 1706 1732 -5373 0 1753 1746 1769 -5374 0 2554 2530 2529 -5375 0 2529 2530 2505 -5376 0 1714 1712 1688 -5377 0 1682 1680 1700 -5378 0 2820 2821 2800 -5379 0 2784 2771 2793 -5380 0 2793 2771 2792 -5381 0 2793 2792 2810 -5382 0 2784 2793 2812 -5383 0 2827 2805 2806 -5384 0 2788 2813 2814 -5385 0 1696 1692 1717 -5386 0 2813 2788 2794 -5387 0 2779 2805 2791 -5388 0 1755 1753 1770 -5389 0 2826 2827 2806 -5390 0 1735 1759 1730 -End Elements - - -Begin Conditions Condition2D -5391 0 2836 2835 -5392 0 2835 2834 -5393 0 2834 2833 -5394 0 2833 2832 -5395 0 2832 2831 -5396 0 2831 2830 -5397 0 2830 2829 -5398 0 2829 2827 -5399 0 2827 2826 -5400 0 2826 2825 -5401 0 2825 2822 -5402 0 2822 2821 -5403 0 2821 2820 -5404 0 2820 2819 -5405 0 2819 2816 -5406 0 2816 2814 -5407 0 2814 2813 -5408 0 2813 2812 -5409 0 2812 2810 -5410 0 2810 2809 -5411 0 1 2 -5412 0 2 5 -5413 0 5 10 -5414 0 10 17 -5415 0 17 25 -5416 0 25 34 -5417 0 34 46 -5418 0 46 60 -5419 0 60 75 -5420 0 75 92 -5421 0 92 113 -5422 0 113 135 -5423 0 135 158 -5424 0 158 182 -5425 0 182 209 -5426 0 209 236 -5427 0 236 268 -5428 0 268 301 -5429 0 301 335 -5430 0 335 369 -5431 0 2809 2792 -5432 0 2792 2770 -5433 0 2770 2747 -5434 0 2747 2723 -5435 0 2723 2699 -5436 0 2699 2675 -5437 0 2675 2651 -5438 0 2651 2627 -5439 0 2627 2603 -5440 0 2603 2578 -5441 0 2578 2553 -5442 0 2553 2529 -5443 0 2529 2505 -5444 0 2505 2481 -5445 0 2481 2457 -5446 0 2457 2433 -5447 0 2433 2409 -5448 0 2409 2385 -5449 0 2385 2360 -5450 0 2360 2335 -5451 0 2335 2311 -5452 0 2311 2287 -5453 0 2287 2263 -5454 0 2263 2239 -5455 0 2239 2215 -5456 0 2215 2191 -5457 0 2191 2167 -5458 0 2167 2143 -5459 0 2143 2119 -5460 0 2119 2095 -5461 0 2095 2071 -5462 0 2071 2047 -5463 0 2047 2023 -5464 0 2023 1999 -5465 0 1999 1974 -5466 0 1974 1949 -5467 0 1949 1925 -5468 0 1925 1900 -5469 0 1900 1876 -5470 0 1876 1852 -5471 0 1852 1828 -5472 0 1828 1804 -5473 0 1804 1780 -5474 0 1780 1757 -5475 0 1757 1735 -5476 0 1735 1716 -5477 0 1716 1693 -5478 0 1693 1665 -5479 0 1665 1643 -5480 0 1643 1619 -5481 0 1619 1595 -5482 0 1595 1570 -5483 0 1570 1545 -5484 0 1545 1521 -5485 0 1521 1496 -5486 0 1496 1472 -5487 0 1472 1449 -5488 0 1449 1424 -5489 0 1424 1401 -5490 0 1401 1378 -5491 0 369 371 -5492 0 371 373 -5493 0 373 378 -5494 0 378 383 -5495 0 383 393 -5496 0 393 401 -5497 0 401 409 -5498 0 409 423 -5499 0 423 433 -5500 0 433 447 -5501 0 447 458 -5502 0 458 476 -5503 0 476 485 -5504 0 485 503 -5505 0 503 522 -5506 0 522 536 -5507 0 536 555 -5508 0 555 575 -5509 0 575 592 -5510 0 592 611 -5511 0 611 626 -5512 0 626 647 -5513 0 647 667 -5514 0 667 689 -5515 0 689 708 -5516 0 708 729 -5517 0 729 748 -5518 0 748 770 -5519 0 770 791 -5520 0 791 812 -5521 0 812 828 -5522 0 828 849 -5523 0 849 870 -5524 0 870 890 -5525 0 890 912 -5526 0 912 934 -5527 0 934 957 -5528 0 957 978 -5529 0 978 999 -5530 0 999 1023 -5531 0 1023 1044 -5532 0 1044 1064 -5533 0 1064 1085 -5534 0 1085 1106 -5535 0 1106 1125 -5536 0 1125 1147 -5537 0 1147 1169 -5538 0 1169 1191 -5539 0 1191 1212 -5540 0 1212 1233 -5541 0 1233 1259 -5542 0 1259 1283 -5543 0 1283 1306 -5544 0 1306 1327 -5545 0 1327 1349 -5546 0 1349 1371 -5547 0 1371 1390 -5548 0 1390 1411 -5549 0 1411 1434 -5550 0 1434 1455 -5551 0 1378 1356 -5552 0 1356 1334 -5553 0 1334 1312 -5554 0 1312 1289 -5555 0 1289 1266 -5556 0 1266 1241 -5557 0 1241 1214 -5558 0 1214 1190 -5559 0 1190 1167 -5560 0 1167 1143 -5561 0 1143 1120 -5562 0 1120 1095 -5563 0 1095 1075 -5564 0 1075 1053 -5565 0 1053 1029 -5566 0 1029 1004 -5567 0 1004 980 -5568 0 980 954 -5569 0 954 929 -5570 0 929 904 -5571 0 904 879 -5572 0 879 856 -5573 0 856 832 -5574 0 832 806 -5575 0 806 781 -5576 0 781 757 -5577 0 757 732 -5578 0 732 707 -5579 0 707 682 -5580 0 682 656 -5581 0 656 627 -5582 0 627 601 -5583 0 601 576 -5584 0 576 550 -5585 0 550 523 -5586 0 523 493 -5587 0 493 462 -5588 0 462 434 -5589 0 434 404 -5590 0 404 370 -5591 0 370 336 -5592 0 336 302 -5593 0 302 269 -5594 0 269 237 -5595 0 237 210 -5596 0 210 183 -5597 0 183 159 -5598 0 159 136 -5599 0 136 114 -5600 0 114 93 -5601 0 93 76 -5602 0 76 61 -5603 0 61 47 -5604 0 47 35 -5605 0 35 26 -5606 0 26 18 -5607 0 18 12 -5608 0 12 6 -5609 0 6 3 -5610 0 3 1 -5611 0 1455 1477 -5612 0 1477 1501 -5613 0 1501 1523 -5614 0 1523 1546 -5615 0 1546 1571 -5616 0 1571 1593 -5617 0 1593 1616 -5618 0 1616 1639 -5619 0 1639 1662 -5620 0 1662 1687 -5621 0 1687 1708 -5622 0 1708 1728 -5623 0 1728 1749 -5624 0 1749 1772 -5625 0 1772 1796 -5626 0 1796 1819 -5627 0 1819 1842 -5628 0 1842 1866 -5629 0 1866 1889 -5630 0 1889 1913 -5631 0 1913 1937 -5632 0 1937 1961 -5633 0 1961 1984 -5634 0 1984 2007 -5635 0 2007 2031 -5636 0 2031 2055 -5637 0 2055 2079 -5638 0 2079 2103 -5639 0 2103 2127 -5640 0 2127 2149 -5641 0 2149 2173 -5642 0 2173 2197 -5643 0 2197 2221 -5644 0 2221 2245 -5645 0 2245 2268 -5646 0 2268 2292 -5647 0 2292 2314 -5648 0 2314 2337 -5649 0 2337 2359 -5650 0 2359 2383 -5651 0 2383 2407 -5652 0 2407 2431 -5653 0 2431 2455 -5654 0 2455 2479 -5655 0 2479 2503 -5656 0 2503 2527 -5657 0 2527 2551 -5658 0 2551 2574 -5659 0 2574 2598 -5660 0 2598 2622 -5661 0 2622 2646 -5662 0 2646 2670 -5663 0 2670 2694 -5664 0 2694 2718 -5665 0 2718 2741 -5666 0 2741 2765 -5667 0 2765 2785 -5668 0 2785 2807 -5669 0 2807 2828 -5670 0 2828 2836 -End Conditions - -Begin Conditions Monolithic2DNeumann -5391 0 2836 2835 -5392 0 2835 2834 -5393 0 2834 2833 -5394 0 2833 2832 -5395 0 2832 2831 -5396 0 2831 2830 -5397 0 2830 2829 -5398 0 2829 2827 -5399 0 2827 2826 -5400 0 2826 2825 -5401 0 2825 2822 -5402 0 2822 2821 -5403 0 2821 2820 -5404 0 2820 2819 -5405 0 2819 2816 -5406 0 2816 2814 -5407 0 2814 2813 -5408 0 2813 2812 -5409 0 2812 2810 -5410 0 2810 2809 -5411 0 1 2 -5412 0 2 5 -5413 0 5 10 -5414 0 10 17 -5415 0 17 25 -5416 0 25 34 -5417 0 34 46 -5418 0 46 60 -5419 0 60 75 -5420 0 75 92 -5421 0 92 113 -5422 0 113 135 -5423 0 135 158 -5424 0 158 182 -5425 0 182 209 -5426 0 209 236 -5427 0 236 268 -5428 0 268 301 -5429 0 301 335 -5430 0 335 369 -End Conditions - - -Begin NodalData DISPLACEMENT_X -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -5 1 0.000000 -6 1 0.000000 -10 1 0.000000 -12 1 0.000000 -17 1 0.000000 -18 1 0.000000 -25 1 0.000000 -26 1 0.000000 -34 1 0.000000 -35 1 0.000000 -46 1 0.000000 -47 1 0.000000 -60 1 0.000000 -61 1 0.000000 -75 1 0.000000 -76 1 0.000000 -92 1 0.000000 -93 1 0.000000 -113 1 0.000000 -114 1 0.000000 -135 1 0.000000 -136 1 0.000000 -158 1 0.000000 -159 1 0.000000 -182 1 0.000000 -183 1 0.000000 -209 1 0.000000 -210 1 0.000000 -236 1 0.000000 -237 1 0.000000 -268 1 0.000000 -269 1 0.000000 -301 1 0.000000 -302 1 0.000000 -335 1 0.000000 -336 1 0.000000 -369 1 0.000000 -370 1 0.000000 -371 1 0.000000 -373 1 0.000000 -378 1 0.000000 -383 1 0.000000 -393 1 0.000000 -401 1 0.000000 -404 1 0.000000 -409 1 0.000000 -423 1 0.000000 -433 1 0.000000 -434 1 0.000000 -447 1 0.000000 -458 1 0.000000 -462 1 0.000000 -476 1 0.000000 -485 1 0.000000 -493 1 0.000000 -503 1 0.000000 -522 1 0.000000 -523 1 0.000000 -536 1 0.000000 -550 1 0.000000 -555 1 0.000000 -575 1 0.000000 -576 1 0.000000 -592 1 0.000000 -601 1 0.000000 -611 1 0.000000 -626 1 0.000000 -627 1 0.000000 -647 1 0.000000 -656 1 0.000000 -667 1 0.000000 -682 1 0.000000 -689 1 0.000000 -707 1 0.000000 -708 1 0.000000 -729 1 0.000000 -732 1 0.000000 -748 1 0.000000 -757 1 0.000000 -770 1 0.000000 -781 1 0.000000 -791 1 0.000000 -806 1 0.000000 -812 1 0.000000 -828 1 0.000000 -832 1 0.000000 -849 1 0.000000 -856 1 0.000000 -870 1 0.000000 -879 1 0.000000 -890 1 0.000000 -904 1 0.000000 -912 1 0.000000 -929 1 0.000000 -934 1 0.000000 -954 1 0.000000 -957 1 0.000000 -978 1 0.000000 -980 1 0.000000 -999 1 0.000000 -1004 1 0.000000 -1023 1 0.000000 -1029 1 0.000000 -1044 1 0.000000 -1053 1 0.000000 -1064 1 0.000000 -1075 1 0.000000 -1085 1 0.000000 -1095 1 0.000000 -1106 1 0.000000 -1120 1 0.000000 -1125 1 0.000000 -1143 1 0.000000 -1147 1 0.000000 -1167 1 0.000000 -1169 1 0.000000 -1190 1 0.000000 -1191 1 0.000000 -1212 1 0.000000 -1214 1 0.000000 -1233 1 0.000000 -1241 1 0.000000 -1259 1 0.000000 -1266 1 0.000000 -1283 1 0.000000 -1289 1 0.000000 -1306 1 0.000000 -1312 1 0.000000 -1327 1 0.000000 -1334 1 0.000000 -1349 1 0.000000 -1356 1 0.000000 -1371 1 0.000000 -1378 1 0.000000 -1390 1 0.000000 -1401 1 0.000000 -1411 1 0.000000 -1424 1 0.000000 -1434 1 0.000000 -1449 1 0.000000 -1455 1 0.000000 -1472 1 0.000000 -1477 1 0.000000 -1496 1 0.000000 -1501 1 0.000000 -1521 1 0.000000 -1523 1 0.000000 -1545 1 0.000000 -1546 1 0.000000 -1570 1 0.000000 -1571 1 0.000000 -1593 1 0.000000 -1595 1 0.000000 -1616 1 0.000000 -1619 1 0.000000 -1639 1 0.000000 -1643 1 0.000000 -1662 1 0.000000 -1665 1 0.000000 -1687 1 0.000000 -1693 1 0.000000 -1708 1 0.000000 -1716 1 0.000000 -1728 1 0.000000 -1735 1 0.000000 -1749 1 0.000000 -1757 1 0.000000 -1772 1 0.000000 -1780 1 0.000000 -1796 1 0.000000 -1804 1 0.000000 -1819 1 0.000000 -1828 1 0.000000 -1842 1 0.000000 -1852 1 0.000000 -1866 1 0.000000 -1876 1 0.000000 -1889 1 0.000000 -1900 1 0.000000 -1913 1 0.000000 -1925 1 0.000000 -1937 1 0.000000 -1949 1 0.000000 -1961 1 0.000000 -1974 1 0.000000 -1984 1 0.000000 -1999 1 0.000000 -2007 1 0.000000 -2023 1 0.000000 -2031 1 0.000000 -2047 1 0.000000 -2055 1 0.000000 -2071 1 0.000000 -2079 1 0.000000 -2095 1 0.000000 -2103 1 0.000000 -2119 1 0.000000 -2127 1 0.000000 -2143 1 0.000000 -2149 1 0.000000 -2167 1 0.000000 -2173 1 0.000000 -2191 1 0.000000 -2197 1 0.000000 -2215 1 0.000000 -2221 1 0.000000 -2239 1 0.000000 -2245 1 0.000000 -2263 1 0.000000 -2268 1 0.000000 -2287 1 0.000000 -2292 1 0.000000 -2311 1 0.000000 -2314 1 0.000000 -2335 1 0.000000 -2337 1 0.000000 -2359 1 0.000000 -2360 1 0.000000 -2383 1 0.000000 -2385 1 0.000000 -2407 1 0.000000 -2409 1 0.000000 -2431 1 0.000000 -2433 1 0.000000 -2455 1 0.000000 -2457 1 0.000000 -2479 1 0.000000 -2481 1 0.000000 -2503 1 0.000000 -2505 1 0.000000 -2527 1 0.000000 -2529 1 0.000000 -2551 1 0.000000 -2553 1 0.000000 -2574 1 0.000000 -2578 1 0.000000 -2598 1 0.000000 -2603 1 0.000000 -2622 1 0.000000 -2627 1 0.000000 -2646 1 0.000000 -2651 1 0.000000 -2670 1 0.000000 -2675 1 0.000000 -2694 1 0.000000 -2699 1 0.000000 -2718 1 0.000000 -2723 1 0.000000 -2741 1 0.000000 -2747 1 0.000000 -2765 1 0.000000 -2770 1 0.000000 -2785 1 0.000000 -2792 1 0.000000 -2807 1 0.000000 -2809 1 0.000000 -2810 1 0.000000 -2812 1 0.000000 -2813 1 0.000000 -2814 1 0.000000 -2816 1 0.000000 -2819 1 0.000000 -2820 1 0.000000 -2821 1 0.000000 -2822 1 0.000000 -2825 1 0.000000 -2826 1 0.000000 -2827 1 0.000000 -2828 1 0.000000 -2829 1 0.000000 -2830 1 0.000000 -2831 1 0.000000 -2832 1 0.000000 -2833 1 0.000000 -2834 1 0.000000 -2835 1 0.000000 -2836 1 0.000000 -End NodalData - -Begin NodalData DISPLACEMENT_Y -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -5 1 0.000000 -6 1 0.000000 -10 1 0.000000 -12 1 0.000000 -17 1 0.000000 -18 1 0.000000 -25 1 0.000000 -26 1 0.000000 -34 1 0.000000 -35 1 0.000000 -46 1 0.000000 -47 1 0.000000 -60 1 0.000000 -61 1 0.000000 -75 1 0.000000 -76 1 0.000000 -92 1 0.000000 -93 1 0.000000 -113 1 0.000000 -114 1 0.000000 -135 1 0.000000 -136 1 0.000000 -158 1 0.000000 -159 1 0.000000 -182 1 0.000000 -183 1 0.000000 -209 1 0.000000 -210 1 0.000000 -236 1 0.000000 -237 1 0.000000 -268 1 0.000000 -269 1 0.000000 -301 1 0.000000 -302 1 0.000000 -335 1 0.000000 -336 1 0.000000 -369 1 0.000000 -370 1 0.000000 -371 1 0.000000 -373 1 0.000000 -378 1 0.000000 -383 1 0.000000 -393 1 0.000000 -401 1 0.000000 -404 1 0.000000 -409 1 0.000000 -423 1 0.000000 -433 1 0.000000 -434 1 0.000000 -447 1 0.000000 -458 1 0.000000 -462 1 0.000000 -476 1 0.000000 -485 1 0.000000 -493 1 0.000000 -503 1 0.000000 -522 1 0.000000 -523 1 0.000000 -536 1 0.000000 -550 1 0.000000 -555 1 0.000000 -575 1 0.000000 -576 1 0.000000 -592 1 0.000000 -601 1 0.000000 -611 1 0.000000 -626 1 0.000000 -627 1 0.000000 -647 1 0.000000 -656 1 0.000000 -667 1 0.000000 -682 1 0.000000 -689 1 0.000000 -707 1 0.000000 -708 1 0.000000 -729 1 0.000000 -732 1 0.000000 -748 1 0.000000 -757 1 0.000000 -770 1 0.000000 -781 1 0.000000 -791 1 0.000000 -806 1 0.000000 -812 1 0.000000 -828 1 0.000000 -832 1 0.000000 -849 1 0.000000 -856 1 0.000000 -870 1 0.000000 -879 1 0.000000 -890 1 0.000000 -904 1 0.000000 -912 1 0.000000 -929 1 0.000000 -934 1 0.000000 -954 1 0.000000 -957 1 0.000000 -978 1 0.000000 -980 1 0.000000 -999 1 0.000000 -1004 1 0.000000 -1023 1 0.000000 -1029 1 0.000000 -1044 1 0.000000 -1053 1 0.000000 -1064 1 0.000000 -1075 1 0.000000 -1085 1 0.000000 -1095 1 0.000000 -1106 1 0.000000 -1120 1 0.000000 -1125 1 0.000000 -1143 1 0.000000 -1147 1 0.000000 -1167 1 0.000000 -1169 1 0.000000 -1190 1 0.000000 -1191 1 0.000000 -1212 1 0.000000 -1214 1 0.000000 -1233 1 0.000000 -1241 1 0.000000 -1259 1 0.000000 -1266 1 0.000000 -1283 1 0.000000 -1289 1 0.000000 -1306 1 0.000000 -1312 1 0.000000 -1327 1 0.000000 -1334 1 0.000000 -1349 1 0.000000 -1356 1 0.000000 -1371 1 0.000000 -1378 1 0.000000 -1390 1 0.000000 -1401 1 0.000000 -1411 1 0.000000 -1424 1 0.000000 -1434 1 0.000000 -1449 1 0.000000 -1455 1 0.000000 -1472 1 0.000000 -1477 1 0.000000 -1496 1 0.000000 -1501 1 0.000000 -1521 1 0.000000 -1523 1 0.000000 -1545 1 0.000000 -1546 1 0.000000 -1570 1 0.000000 -1571 1 0.000000 -1593 1 0.000000 -1595 1 0.000000 -1616 1 0.000000 -1619 1 0.000000 -1639 1 0.000000 -1643 1 0.000000 -1662 1 0.000000 -1665 1 0.000000 -1687 1 0.000000 -1693 1 0.000000 -1708 1 0.000000 -1716 1 0.000000 -1728 1 0.000000 -1735 1 0.000000 -1749 1 0.000000 -1757 1 0.000000 -1772 1 0.000000 -1780 1 0.000000 -1796 1 0.000000 -1804 1 0.000000 -1819 1 0.000000 -1828 1 0.000000 -1842 1 0.000000 -1852 1 0.000000 -1866 1 0.000000 -1876 1 0.000000 -1889 1 0.000000 -1900 1 0.000000 -1913 1 0.000000 -1925 1 0.000000 -1937 1 0.000000 -1949 1 0.000000 -1961 1 0.000000 -1974 1 0.000000 -1984 1 0.000000 -1999 1 0.000000 -2007 1 0.000000 -2023 1 0.000000 -2031 1 0.000000 -2047 1 0.000000 -2055 1 0.000000 -2071 1 0.000000 -2079 1 0.000000 -2095 1 0.000000 -2103 1 0.000000 -2119 1 0.000000 -2127 1 0.000000 -2143 1 0.000000 -2149 1 0.000000 -2167 1 0.000000 -2173 1 0.000000 -2191 1 0.000000 -2197 1 0.000000 -2215 1 0.000000 -2221 1 0.000000 -2239 1 0.000000 -2245 1 0.000000 -2263 1 0.000000 -2268 1 0.000000 -2287 1 0.000000 -2292 1 0.000000 -2311 1 0.000000 -2314 1 0.000000 -2335 1 0.000000 -2337 1 0.000000 -2359 1 0.000000 -2360 1 0.000000 -2383 1 0.000000 -2385 1 0.000000 -2407 1 0.000000 -2409 1 0.000000 -2431 1 0.000000 -2433 1 0.000000 -2455 1 0.000000 -2457 1 0.000000 -2479 1 0.000000 -2481 1 0.000000 -2503 1 0.000000 -2505 1 0.000000 -2527 1 0.000000 -2529 1 0.000000 -2551 1 0.000000 -2553 1 0.000000 -2574 1 0.000000 -2578 1 0.000000 -2598 1 0.000000 -2603 1 0.000000 -2622 1 0.000000 -2627 1 0.000000 -2646 1 0.000000 -2651 1 0.000000 -2670 1 0.000000 -2675 1 0.000000 -2694 1 0.000000 -2699 1 0.000000 -2718 1 0.000000 -2723 1 0.000000 -2741 1 0.000000 -2747 1 0.000000 -2765 1 0.000000 -2770 1 0.000000 -2785 1 0.000000 -2792 1 0.000000 -2807 1 0.000000 -2809 1 0.000000 -2810 1 0.000000 -2812 1 0.000000 -2813 1 0.000000 -2814 1 0.000000 -2816 1 0.000000 -2819 1 0.000000 -2820 1 0.000000 -2821 1 0.000000 -2822 1 0.000000 -2825 1 0.000000 -2826 1 0.000000 -2827 1 0.000000 -2828 1 0.000000 -2829 1 0.000000 -2830 1 0.000000 -2831 1 0.000000 -2832 1 0.000000 -2833 1 0.000000 -2834 1 0.000000 -2835 1 0.000000 -2836 1 0.000000 -End NodalData - -Begin NodalData DISPLACEMENT_Z -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -5 1 0.000000 -6 1 0.000000 -10 1 0.000000 -12 1 0.000000 -17 1 0.000000 -18 1 0.000000 -25 1 0.000000 -26 1 0.000000 -34 1 0.000000 -35 1 0.000000 -46 1 0.000000 -47 1 0.000000 -60 1 0.000000 -61 1 0.000000 -75 1 0.000000 -76 1 0.000000 -92 1 0.000000 -93 1 0.000000 -113 1 0.000000 -114 1 0.000000 -135 1 0.000000 -136 1 0.000000 -158 1 0.000000 -159 1 0.000000 -182 1 0.000000 -183 1 0.000000 -209 1 0.000000 -210 1 0.000000 -236 1 0.000000 -237 1 0.000000 -268 1 0.000000 -269 1 0.000000 -301 1 0.000000 -302 1 0.000000 -335 1 0.000000 -336 1 0.000000 -369 1 0.000000 -370 1 0.000000 -371 1 0.000000 -373 1 0.000000 -378 1 0.000000 -383 1 0.000000 -393 1 0.000000 -401 1 0.000000 -404 1 0.000000 -409 1 0.000000 -423 1 0.000000 -433 1 0.000000 -434 1 0.000000 -447 1 0.000000 -458 1 0.000000 -462 1 0.000000 -476 1 0.000000 -485 1 0.000000 -493 1 0.000000 -503 1 0.000000 -522 1 0.000000 -523 1 0.000000 -536 1 0.000000 -550 1 0.000000 -555 1 0.000000 -575 1 0.000000 -576 1 0.000000 -592 1 0.000000 -601 1 0.000000 -611 1 0.000000 -626 1 0.000000 -627 1 0.000000 -647 1 0.000000 -656 1 0.000000 -667 1 0.000000 -682 1 0.000000 -689 1 0.000000 -707 1 0.000000 -708 1 0.000000 -729 1 0.000000 -732 1 0.000000 -748 1 0.000000 -757 1 0.000000 -770 1 0.000000 -781 1 0.000000 -791 1 0.000000 -806 1 0.000000 -812 1 0.000000 -828 1 0.000000 -832 1 0.000000 -849 1 0.000000 -856 1 0.000000 -870 1 0.000000 -879 1 0.000000 -890 1 0.000000 -904 1 0.000000 -912 1 0.000000 -929 1 0.000000 -934 1 0.000000 -954 1 0.000000 -957 1 0.000000 -978 1 0.000000 -980 1 0.000000 -999 1 0.000000 -1004 1 0.000000 -1023 1 0.000000 -1029 1 0.000000 -1044 1 0.000000 -1053 1 0.000000 -1064 1 0.000000 -1075 1 0.000000 -1085 1 0.000000 -1095 1 0.000000 -1106 1 0.000000 -1120 1 0.000000 -1125 1 0.000000 -1143 1 0.000000 -1147 1 0.000000 -1167 1 0.000000 -1169 1 0.000000 -1190 1 0.000000 -1191 1 0.000000 -1212 1 0.000000 -1214 1 0.000000 -1233 1 0.000000 -1241 1 0.000000 -1259 1 0.000000 -1266 1 0.000000 -1283 1 0.000000 -1289 1 0.000000 -1306 1 0.000000 -1312 1 0.000000 -1327 1 0.000000 -1334 1 0.000000 -1349 1 0.000000 -1356 1 0.000000 -1371 1 0.000000 -1378 1 0.000000 -1390 1 0.000000 -1401 1 0.000000 -1411 1 0.000000 -1424 1 0.000000 -1434 1 0.000000 -1449 1 0.000000 -1455 1 0.000000 -1472 1 0.000000 -1477 1 0.000000 -1496 1 0.000000 -1501 1 0.000000 -1521 1 0.000000 -1523 1 0.000000 -1545 1 0.000000 -1546 1 0.000000 -1570 1 0.000000 -1571 1 0.000000 -1593 1 0.000000 -1595 1 0.000000 -1616 1 0.000000 -1619 1 0.000000 -1639 1 0.000000 -1643 1 0.000000 -1662 1 0.000000 -1665 1 0.000000 -1687 1 0.000000 -1693 1 0.000000 -1708 1 0.000000 -1716 1 0.000000 -1728 1 0.000000 -1735 1 0.000000 -1749 1 0.000000 -1757 1 0.000000 -1772 1 0.000000 -1780 1 0.000000 -1796 1 0.000000 -1804 1 0.000000 -1819 1 0.000000 -1828 1 0.000000 -1842 1 0.000000 -1852 1 0.000000 -1866 1 0.000000 -1876 1 0.000000 -1889 1 0.000000 -1900 1 0.000000 -1913 1 0.000000 -1925 1 0.000000 -1937 1 0.000000 -1949 1 0.000000 -1961 1 0.000000 -1974 1 0.000000 -1984 1 0.000000 -1999 1 0.000000 -2007 1 0.000000 -2023 1 0.000000 -2031 1 0.000000 -2047 1 0.000000 -2055 1 0.000000 -2071 1 0.000000 -2079 1 0.000000 -2095 1 0.000000 -2103 1 0.000000 -2119 1 0.000000 -2127 1 0.000000 -2143 1 0.000000 -2149 1 0.000000 -2167 1 0.000000 -2173 1 0.000000 -2191 1 0.000000 -2197 1 0.000000 -2215 1 0.000000 -2221 1 0.000000 -2239 1 0.000000 -2245 1 0.000000 -2263 1 0.000000 -2268 1 0.000000 -2287 1 0.000000 -2292 1 0.000000 -2311 1 0.000000 -2314 1 0.000000 -2335 1 0.000000 -2337 1 0.000000 -2359 1 0.000000 -2360 1 0.000000 -2383 1 0.000000 -2385 1 0.000000 -2407 1 0.000000 -2409 1 0.000000 -2431 1 0.000000 -2433 1 0.000000 -2455 1 0.000000 -2457 1 0.000000 -2479 1 0.000000 -2481 1 0.000000 -2503 1 0.000000 -2505 1 0.000000 -2527 1 0.000000 -2529 1 0.000000 -2551 1 0.000000 -2553 1 0.000000 -2574 1 0.000000 -2578 1 0.000000 -2598 1 0.000000 -2603 1 0.000000 -2622 1 0.000000 -2627 1 0.000000 -2646 1 0.000000 -2651 1 0.000000 -2670 1 0.000000 -2675 1 0.000000 -2694 1 0.000000 -2699 1 0.000000 -2718 1 0.000000 -2723 1 0.000000 -2741 1 0.000000 -2747 1 0.000000 -2765 1 0.000000 -2770 1 0.000000 -2785 1 0.000000 -2792 1 0.000000 -2807 1 0.000000 -2809 1 0.000000 -2810 1 0.000000 -2812 1 0.000000 -2813 1 0.000000 -2814 1 0.000000 -2816 1 0.000000 -2819 1 0.000000 -2820 1 0.000000 -2821 1 0.000000 -2822 1 0.000000 -2825 1 0.000000 -2826 1 0.000000 -2827 1 0.000000 -2828 1 0.000000 -2829 1 0.000000 -2830 1 0.000000 -2831 1 0.000000 -2832 1 0.000000 -2833 1 0.000000 -2834 1 0.000000 -2835 1 0.000000 -2836 1 0.000000 -End NodalData - -Begin NodalData VELOCITY_X -1 1 0.000000 -3 1 0.000000 -6 1 0.000000 -12 1 0.000000 -18 1 0.000000 -26 1 0.000000 -35 1 0.000000 -47 1 0.000000 -61 1 0.000000 -76 1 0.000000 -93 1 0.000000 -114 1 0.000000 -136 1 0.000000 -159 1 0.000000 -183 1 0.000000 -210 1 0.000000 -237 1 0.000000 -269 1 0.000000 -302 1 0.000000 -336 1 0.000000 -369 1 0.010000 -370 1 0.000000 -371 1 0.010000 -373 1 0.010000 -378 1 0.010000 -383 1 0.010000 -393 1 0.010000 -401 1 0.010000 -404 1 0.000000 -409 1 0.010000 -423 1 0.010000 -433 1 0.010000 -434 1 0.000000 -447 1 0.010000 -458 1 0.010000 -462 1 0.000000 -476 1 0.010000 -485 1 0.010000 -493 1 0.000000 -503 1 0.010000 -522 1 0.010000 -523 1 0.000000 -536 1 0.010000 -550 1 0.000000 -555 1 0.010000 -575 1 0.010000 -576 1 0.000000 -592 1 0.010000 -601 1 0.000000 -611 1 0.010000 -626 1 0.010000 -627 1 0.000000 -647 1 0.010000 -656 1 0.000000 -667 1 0.010000 -682 1 0.000000 -689 1 0.010000 -707 1 0.000000 -708 1 0.010000 -729 1 0.010000 -732 1 0.000000 -748 1 0.010000 -757 1 0.000000 -770 1 0.010000 -781 1 0.000000 -791 1 0.010000 -806 1 0.000000 -812 1 0.010000 -828 1 0.010000 -832 1 0.000000 -849 1 0.010000 -856 1 0.000000 -870 1 0.010000 -879 1 0.000000 -890 1 0.010000 -904 1 0.000000 -912 1 0.010000 -929 1 0.000000 -934 1 0.010000 -954 1 0.000000 -957 1 0.010000 -978 1 0.010000 -980 1 0.000000 -999 1 0.010000 -1004 1 0.000000 -1023 1 0.010000 -1029 1 0.000000 -1044 1 0.010000 -1053 1 0.000000 -1064 1 0.010000 -1075 1 0.000000 -1085 1 0.010000 -1095 1 0.000000 -1106 1 0.010000 -1120 1 0.000000 -1125 1 0.010000 -1143 1 0.000000 -1147 1 0.010000 -1167 1 0.000000 -1169 1 0.010000 -1190 1 0.000000 -1191 1 0.010000 -1212 1 0.010000 -1214 1 0.000000 -1233 1 0.010000 -1241 1 0.000000 -1259 1 0.010000 -1266 1 0.000000 -1283 1 0.010000 -1289 1 0.000000 -1306 1 0.010000 -1312 1 0.000000 -1327 1 0.010000 -1334 1 0.000000 -1349 1 0.010000 -1356 1 0.000000 -1371 1 0.010000 -1378 1 0.000000 -1390 1 0.010000 -1401 1 0.000000 -1411 1 0.010000 -1424 1 0.000000 -1434 1 0.010000 -1449 1 0.000000 -1455 1 0.010000 -1472 1 0.000000 -1477 1 0.010000 -1496 1 0.000000 -1501 1 0.010000 -1521 1 0.000000 -1523 1 0.010000 -1545 1 0.000000 -1546 1 0.010000 -1570 1 0.000000 -1571 1 0.010000 -1593 1 0.010000 -1595 1 0.000000 -1616 1 0.010000 -1619 1 0.000000 -1639 1 0.010000 -1643 1 0.000000 -1662 1 0.010000 -1665 1 0.000000 -1687 1 0.010000 -1693 1 0.000000 -1708 1 0.010000 -1716 1 0.000000 -1728 1 0.010000 -1735 1 0.000000 -1749 1 0.010000 -1757 1 0.000000 -1772 1 0.010000 -1780 1 0.000000 -1796 1 0.010000 -1804 1 0.000000 -1819 1 0.010000 -1828 1 0.000000 -1842 1 0.010000 -1852 1 0.000000 -1866 1 0.010000 -1876 1 0.000000 -1889 1 0.010000 -1900 1 0.000000 -1913 1 0.010000 -1925 1 0.000000 -1937 1 0.010000 -1949 1 0.000000 -1961 1 0.010000 -1974 1 0.000000 -1984 1 0.010000 -1999 1 0.000000 -2007 1 0.010000 -2023 1 0.000000 -2031 1 0.010000 -2047 1 0.000000 -2055 1 0.010000 -2071 1 0.000000 -2079 1 0.010000 -2095 1 0.000000 -2103 1 0.010000 -2119 1 0.000000 -2127 1 0.010000 -2143 1 0.000000 -2149 1 0.010000 -2167 1 0.000000 -2173 1 0.010000 -2191 1 0.000000 -2197 1 0.010000 -2215 1 0.000000 -2221 1 0.010000 -2239 1 0.000000 -2245 1 0.010000 -2263 1 0.000000 -2268 1 0.010000 -2287 1 0.000000 -2292 1 0.010000 -2311 1 0.000000 -2314 1 0.010000 -2335 1 0.000000 -2337 1 0.010000 -2359 1 0.010000 -2360 1 0.000000 -2383 1 0.010000 -2385 1 0.000000 -2407 1 0.010000 -2409 1 0.000000 -2431 1 0.010000 -2433 1 0.000000 -2455 1 0.010000 -2457 1 0.000000 -2479 1 0.010000 -2481 1 0.000000 -2503 1 0.010000 -2505 1 0.000000 -2527 1 0.010000 -2529 1 0.000000 -2551 1 0.010000 -2553 1 0.000000 -2574 1 0.010000 -2578 1 0.000000 -2598 1 0.010000 -2603 1 0.000000 -2622 1 0.010000 -2627 1 0.000000 -2646 1 0.010000 -2651 1 0.000000 -2670 1 0.010000 -2675 1 0.000000 -2694 1 0.010000 -2699 1 0.000000 -2718 1 0.010000 -2723 1 0.000000 -2741 1 0.010000 -2747 1 0.000000 -2765 1 0.010000 -2770 1 0.000000 -2785 1 0.010000 -2792 1 0.000000 -2807 1 0.010000 -2809 1 0.000000 -2828 1 0.010000 -2836 1 0.010000 -End NodalData - -Begin NodalData VELOCITY_Y -1 1 0.000000 -3 1 0.000000 -6 1 0.000000 -12 1 0.000000 -18 1 0.000000 -26 1 0.000000 -35 1 0.000000 -47 1 0.000000 -61 1 0.000000 -76 1 0.000000 -93 1 0.000000 -114 1 0.000000 -136 1 0.000000 -159 1 0.000000 -183 1 0.000000 -210 1 0.000000 -237 1 0.000000 -269 1 0.000000 -302 1 0.000000 -336 1 0.000000 -369 1 0.000000 -370 1 0.000000 -371 1 0.000000 -373 1 0.000000 -378 1 0.000000 -383 1 0.000000 -393 1 0.000000 -401 1 0.000000 -404 1 0.000000 -409 1 0.000000 -423 1 0.000000 -433 1 0.000000 -434 1 0.000000 -447 1 0.000000 -458 1 0.000000 -462 1 0.000000 -476 1 0.000000 -485 1 0.000000 -493 1 0.000000 -503 1 0.000000 -522 1 0.000000 -523 1 0.000000 -536 1 0.000000 -550 1 0.000000 -555 1 0.000000 -575 1 0.000000 -576 1 0.000000 -592 1 0.000000 -601 1 0.000000 -611 1 0.000000 -626 1 0.000000 -627 1 0.000000 -647 1 0.000000 -656 1 0.000000 -667 1 0.000000 -682 1 0.000000 -689 1 0.000000 -707 1 0.000000 -708 1 0.000000 -729 1 0.000000 -732 1 0.000000 -748 1 0.000000 -757 1 0.000000 -770 1 0.000000 -781 1 0.000000 -791 1 0.000000 -806 1 0.000000 -812 1 0.000000 -828 1 0.000000 -832 1 0.000000 -849 1 0.000000 -856 1 0.000000 -870 1 0.000000 -879 1 0.000000 -890 1 0.000000 -904 1 0.000000 -912 1 0.000000 -929 1 0.000000 -934 1 0.000000 -954 1 0.000000 -957 1 0.000000 -978 1 0.000000 -980 1 0.000000 -999 1 0.000000 -1004 1 0.000000 -1023 1 0.000000 -1029 1 0.000000 -1044 1 0.000000 -1053 1 0.000000 -1064 1 0.000000 -1075 1 0.000000 -1085 1 0.000000 -1095 1 0.000000 -1106 1 0.000000 -1120 1 0.000000 -1125 1 0.000000 -1143 1 0.000000 -1147 1 0.000000 -1167 1 0.000000 -1169 1 0.000000 -1190 1 0.000000 -1191 1 0.000000 -1212 1 0.000000 -1214 1 0.000000 -1233 1 0.000000 -1241 1 0.000000 -1259 1 0.000000 -1266 1 0.000000 -1283 1 0.000000 -1289 1 0.000000 -1306 1 0.000000 -1312 1 0.000000 -1327 1 0.000000 -1334 1 0.000000 -1349 1 0.000000 -1356 1 0.000000 -1371 1 0.000000 -1378 1 0.000000 -1390 1 0.000000 -1401 1 0.000000 -1411 1 0.000000 -1424 1 0.000000 -1434 1 0.000000 -1449 1 0.000000 -1455 1 0.000000 -1472 1 0.000000 -1477 1 0.000000 -1496 1 0.000000 -1501 1 0.000000 -1521 1 0.000000 -1523 1 0.000000 -1545 1 0.000000 -1546 1 0.000000 -1570 1 0.000000 -1571 1 0.000000 -1593 1 0.000000 -1595 1 0.000000 -1616 1 0.000000 -1619 1 0.000000 -1639 1 0.000000 -1643 1 0.000000 -1662 1 0.000000 -1665 1 0.000000 -1687 1 0.000000 -1693 1 0.000000 -1708 1 0.000000 -1716 1 0.000000 -1728 1 0.000000 -1735 1 0.000000 -1749 1 0.000000 -1757 1 0.000000 -1772 1 0.000000 -1780 1 0.000000 -1796 1 0.000000 -1804 1 0.000000 -1819 1 0.000000 -1828 1 0.000000 -1842 1 0.000000 -1852 1 0.000000 -1866 1 0.000000 -1876 1 0.000000 -1889 1 0.000000 -1900 1 0.000000 -1913 1 0.000000 -1925 1 0.000000 -1937 1 0.000000 -1949 1 0.000000 -1961 1 0.000000 -1974 1 0.000000 -1984 1 0.000000 -1999 1 0.000000 -2007 1 0.000000 -2023 1 0.000000 -2031 1 0.000000 -2047 1 0.000000 -2055 1 0.000000 -2071 1 0.000000 -2079 1 0.000000 -2095 1 0.000000 -2103 1 0.000000 -2119 1 0.000000 -2127 1 0.000000 -2143 1 0.000000 -2149 1 0.000000 -2167 1 0.000000 -2173 1 0.000000 -2191 1 0.000000 -2197 1 0.000000 -2215 1 0.000000 -2221 1 0.000000 -2239 1 0.000000 -2245 1 0.000000 -2263 1 0.000000 -2268 1 0.000000 -2287 1 0.000000 -2292 1 0.000000 -2311 1 0.000000 -2314 1 0.000000 -2335 1 0.000000 -2337 1 0.000000 -2359 1 0.000000 -2360 1 0.000000 -2383 1 0.000000 -2385 1 0.000000 -2407 1 0.000000 -2409 1 0.000000 -2431 1 0.000000 -2433 1 0.000000 -2455 1 0.000000 -2457 1 0.000000 -2479 1 0.000000 -2481 1 0.000000 -2503 1 0.000000 -2505 1 0.000000 -2527 1 0.000000 -2529 1 0.000000 -2551 1 0.000000 -2553 1 0.000000 -2574 1 0.000000 -2578 1 0.000000 -2598 1 0.000000 -2603 1 0.000000 -2622 1 0.000000 -2627 1 0.000000 -2646 1 0.000000 -2651 1 0.000000 -2670 1 0.000000 -2675 1 0.000000 -2694 1 0.000000 -2699 1 0.000000 -2718 1 0.000000 -2723 1 0.000000 -2741 1 0.000000 -2747 1 0.000000 -2765 1 0.000000 -2770 1 0.000000 -2785 1 0.000000 -2792 1 0.000000 -2807 1 0.000000 -2809 1 0.000000 -2828 1 0.000000 -2836 1 0.000000 -End NodalData - -Begin NodalData VELOCITY_Z -1 1 0.000000 -3 1 0.000000 -6 1 0.000000 -12 1 0.000000 -18 1 0.000000 -26 1 0.000000 -35 1 0.000000 -47 1 0.000000 -61 1 0.000000 -76 1 0.000000 -93 1 0.000000 -114 1 0.000000 -136 1 0.000000 -159 1 0.000000 -183 1 0.000000 -210 1 0.000000 -237 1 0.000000 -269 1 0.000000 -302 1 0.000000 -336 1 0.000000 -369 1 0.000000 -370 1 0.000000 -371 1 0.000000 -373 1 0.000000 -378 1 0.000000 -383 1 0.000000 -393 1 0.000000 -401 1 0.000000 -404 1 0.000000 -409 1 0.000000 -423 1 0.000000 -433 1 0.000000 -434 1 0.000000 -447 1 0.000000 -458 1 0.000000 -462 1 0.000000 -476 1 0.000000 -485 1 0.000000 -493 1 0.000000 -503 1 0.000000 -522 1 0.000000 -523 1 0.000000 -536 1 0.000000 -550 1 0.000000 -555 1 0.000000 -575 1 0.000000 -576 1 0.000000 -592 1 0.000000 -601 1 0.000000 -611 1 0.000000 -626 1 0.000000 -627 1 0.000000 -647 1 0.000000 -656 1 0.000000 -667 1 0.000000 -682 1 0.000000 -689 1 0.000000 -707 1 0.000000 -708 1 0.000000 -729 1 0.000000 -732 1 0.000000 -748 1 0.000000 -757 1 0.000000 -770 1 0.000000 -781 1 0.000000 -791 1 0.000000 -806 1 0.000000 -812 1 0.000000 -828 1 0.000000 -832 1 0.000000 -849 1 0.000000 -856 1 0.000000 -870 1 0.000000 -879 1 0.000000 -890 1 0.000000 -904 1 0.000000 -912 1 0.000000 -929 1 0.000000 -934 1 0.000000 -954 1 0.000000 -957 1 0.000000 -978 1 0.000000 -980 1 0.000000 -999 1 0.000000 -1004 1 0.000000 -1023 1 0.000000 -1029 1 0.000000 -1044 1 0.000000 -1053 1 0.000000 -1064 1 0.000000 -1075 1 0.000000 -1085 1 0.000000 -1095 1 0.000000 -1106 1 0.000000 -1120 1 0.000000 -1125 1 0.000000 -1143 1 0.000000 -1147 1 0.000000 -1167 1 0.000000 -1169 1 0.000000 -1190 1 0.000000 -1191 1 0.000000 -1212 1 0.000000 -1214 1 0.000000 -1233 1 0.000000 -1241 1 0.000000 -1259 1 0.000000 -1266 1 0.000000 -1283 1 0.000000 -1289 1 0.000000 -1306 1 0.000000 -1312 1 0.000000 -1327 1 0.000000 -1334 1 0.000000 -1349 1 0.000000 -1356 1 0.000000 -1371 1 0.000000 -1378 1 0.000000 -1390 1 0.000000 -1401 1 0.000000 -1411 1 0.000000 -1424 1 0.000000 -1434 1 0.000000 -1449 1 0.000000 -1455 1 0.000000 -1472 1 0.000000 -1477 1 0.000000 -1496 1 0.000000 -1501 1 0.000000 -1521 1 0.000000 -1523 1 0.000000 -1545 1 0.000000 -1546 1 0.000000 -1570 1 0.000000 -1571 1 0.000000 -1593 1 0.000000 -1595 1 0.000000 -1616 1 0.000000 -1619 1 0.000000 -1639 1 0.000000 -1643 1 0.000000 -1662 1 0.000000 -1665 1 0.000000 -1687 1 0.000000 -1693 1 0.000000 -1708 1 0.000000 -1716 1 0.000000 -1728 1 0.000000 -1735 1 0.000000 -1749 1 0.000000 -1757 1 0.000000 -1772 1 0.000000 -1780 1 0.000000 -1796 1 0.000000 -1804 1 0.000000 -1819 1 0.000000 -1828 1 0.000000 -1842 1 0.000000 -1852 1 0.000000 -1866 1 0.000000 -1876 1 0.000000 -1889 1 0.000000 -1900 1 0.000000 -1913 1 0.000000 -1925 1 0.000000 -1937 1 0.000000 -1949 1 0.000000 -1961 1 0.000000 -1974 1 0.000000 -1984 1 0.000000 -1999 1 0.000000 -2007 1 0.000000 -2023 1 0.000000 -2031 1 0.000000 -2047 1 0.000000 -2055 1 0.000000 -2071 1 0.000000 -2079 1 0.000000 -2095 1 0.000000 -2103 1 0.000000 -2119 1 0.000000 -2127 1 0.000000 -2143 1 0.000000 -2149 1 0.000000 -2167 1 0.000000 -2173 1 0.000000 -2191 1 0.000000 -2197 1 0.000000 -2215 1 0.000000 -2221 1 0.000000 -2239 1 0.000000 -2245 1 0.000000 -2263 1 0.000000 -2268 1 0.000000 -2287 1 0.000000 -2292 1 0.000000 -2311 1 0.000000 -2314 1 0.000000 -2335 1 0.000000 -2337 1 0.000000 -2359 1 0.000000 -2360 1 0.000000 -2383 1 0.000000 -2385 1 0.000000 -2407 1 0.000000 -2409 1 0.000000 -2431 1 0.000000 -2433 1 0.000000 -2455 1 0.000000 -2457 1 0.000000 -2479 1 0.000000 -2481 1 0.000000 -2503 1 0.000000 -2505 1 0.000000 -2527 1 0.000000 -2529 1 0.000000 -2551 1 0.000000 -2553 1 0.000000 -2574 1 0.000000 -2578 1 0.000000 -2598 1 0.000000 -2603 1 0.000000 -2622 1 0.000000 -2627 1 0.000000 -2646 1 0.000000 -2651 1 0.000000 -2670 1 0.000000 -2675 1 0.000000 -2694 1 0.000000 -2699 1 0.000000 -2718 1 0.000000 -2723 1 0.000000 -2741 1 0.000000 -2747 1 0.000000 -2765 1 0.000000 -2770 1 0.000000 -2785 1 0.000000 -2792 1 0.000000 -2807 1 0.000000 -2809 1 0.000000 -2828 1 0.000000 -2836 1 0.000000 -End NodalData - -Begin NodalData EXTERNAL_PRESSURE -1 0 1700.000000 -2 0 1700.000000 -5 0 1700.000000 -10 0 1700.000000 -17 0 1700.000000 -25 0 1700.000000 -34 0 1700.000000 -46 0 1700.000000 -60 0 1700.000000 -75 0 1700.000000 -92 0 1700.000000 -113 0 1700.000000 -135 0 1700.000000 -158 0 1700.000000 -182 0 1700.000000 -209 0 1700.000000 -236 0 1700.000000 -268 0 1700.000000 -301 0 1700.000000 -335 0 1700.000000 -369 0 1700.000000 -2809 0 0.000000 -2810 0 0.000000 -2812 0 0.000000 -2813 0 0.000000 -2814 0 0.000000 -2816 0 0.000000 -2819 0 0.000000 -2820 0 0.000000 -2821 0 0.000000 -2822 0 0.000000 -2825 0 0.000000 -2826 0 0.000000 -2827 0 0.000000 -2829 0 0.000000 -2830 0 0.000000 -2831 0 0.000000 -2832 0 0.000000 -2833 0 0.000000 -2834 0 0.000000 -2835 0 0.000000 -2836 0 0.000000 -End NodalData - -Begin NodalData VISCOSITY -1 0 10.000000 -2 0 10.000000 -3 0 10.000000 -4 0 10.000000 -5 0 10.000000 -6 0 10.000000 -7 0 10.000000 -8 0 10.000000 -9 0 10.000000 -10 0 10.000000 -11 0 10.000000 -12 0 10.000000 -13 0 10.000000 -14 0 10.000000 -15 0 10.000000 -16 0 10.000000 -17 0 10.000000 -18 0 10.000000 -19 0 10.000000 -20 0 10.000000 -21 0 10.000000 -22 0 10.000000 -23 0 10.000000 -24 0 10.000000 -25 0 10.000000 -26 0 10.000000 -27 0 10.000000 -28 0 10.000000 -29 0 10.000000 -30 0 10.000000 -31 0 10.000000 -32 0 10.000000 -33 0 10.000000 -34 0 10.000000 -35 0 10.000000 -36 0 10.000000 -37 0 10.000000 -38 0 10.000000 -39 0 10.000000 -40 0 10.000000 -41 0 10.000000 -42 0 10.000000 -43 0 10.000000 -44 0 10.000000 -45 0 10.000000 -46 0 10.000000 -47 0 10.000000 -48 0 10.000000 -49 0 10.000000 -50 0 10.000000 -51 0 10.000000 -52 0 10.000000 -53 0 10.000000 -54 0 10.000000 -55 0 10.000000 -56 0 10.000000 -57 0 10.000000 -58 0 10.000000 -59 0 10.000000 -60 0 10.000000 -61 0 10.000000 -62 0 10.000000 -63 0 10.000000 -64 0 10.000000 -65 0 10.000000 -66 0 10.000000 -67 0 10.000000 -68 0 10.000000 -69 0 10.000000 -70 0 10.000000 -71 0 10.000000 -72 0 10.000000 -73 0 10.000000 -74 0 10.000000 -75 0 10.000000 -76 0 10.000000 -77 0 10.000000 -78 0 10.000000 -79 0 10.000000 -80 0 10.000000 -81 0 10.000000 -82 0 10.000000 -83 0 10.000000 -84 0 10.000000 -85 0 10.000000 -86 0 10.000000 -87 0 10.000000 -88 0 10.000000 -89 0 10.000000 -90 0 10.000000 -91 0 10.000000 -92 0 10.000000 -93 0 10.000000 -94 0 10.000000 -95 0 10.000000 -96 0 10.000000 -97 0 10.000000 -98 0 10.000000 -99 0 10.000000 -100 0 10.000000 -101 0 10.000000 -102 0 10.000000 -103 0 10.000000 -104 0 10.000000 -105 0 10.000000 -106 0 10.000000 -107 0 10.000000 -108 0 10.000000 -109 0 10.000000 -110 0 10.000000 -111 0 10.000000 -112 0 10.000000 -113 0 10.000000 -114 0 10.000000 -115 0 10.000000 -116 0 10.000000 -117 0 10.000000 -118 0 10.000000 -119 0 10.000000 -120 0 10.000000 -121 0 10.000000 -122 0 10.000000 -123 0 10.000000 -124 0 10.000000 -125 0 10.000000 -126 0 10.000000 -127 0 10.000000 -128 0 10.000000 -129 0 10.000000 -130 0 10.000000 -131 0 10.000000 -132 0 10.000000 -133 0 10.000000 -134 0 10.000000 -135 0 10.000000 -136 0 10.000000 -137 0 10.000000 -138 0 10.000000 -139 0 10.000000 -140 0 10.000000 -141 0 10.000000 -142 0 10.000000 -143 0 10.000000 -144 0 10.000000 -145 0 10.000000 -146 0 10.000000 -147 0 10.000000 -148 0 10.000000 -149 0 10.000000 -150 0 10.000000 -151 0 10.000000 -152 0 10.000000 -153 0 10.000000 -154 0 10.000000 -155 0 10.000000 -156 0 10.000000 -157 0 10.000000 -158 0 10.000000 -159 0 10.000000 -160 0 10.000000 -161 0 10.000000 -162 0 10.000000 -163 0 10.000000 -164 0 10.000000 -165 0 10.000000 -166 0 10.000000 -167 0 10.000000 -168 0 10.000000 -169 0 10.000000 -170 0 10.000000 -171 0 10.000000 -172 0 10.000000 -173 0 10.000000 -174 0 10.000000 -175 0 10.000000 -176 0 10.000000 -177 0 10.000000 -178 0 10.000000 -179 0 10.000000 -180 0 10.000000 -181 0 10.000000 -182 0 10.000000 -183 0 10.000000 -184 0 10.000000 -185 0 10.000000 -186 0 10.000000 -187 0 10.000000 -188 0 10.000000 -189 0 10.000000 -190 0 10.000000 -191 0 10.000000 -192 0 10.000000 -193 0 10.000000 -194 0 10.000000 -195 0 10.000000 -196 0 10.000000 -197 0 10.000000 -198 0 10.000000 -199 0 10.000000 -200 0 10.000000 -201 0 10.000000 -202 0 10.000000 -203 0 10.000000 -204 0 10.000000 -205 0 10.000000 -206 0 10.000000 -207 0 10.000000 -208 0 10.000000 -209 0 10.000000 -210 0 10.000000 -211 0 10.000000 -212 0 10.000000 -213 0 10.000000 -214 0 10.000000 -215 0 10.000000 -216 0 10.000000 -217 0 10.000000 -218 0 10.000000 -219 0 10.000000 -220 0 10.000000 -221 0 10.000000 -222 0 10.000000 -223 0 10.000000 -224 0 10.000000 -225 0 10.000000 -226 0 10.000000 -227 0 10.000000 -228 0 10.000000 -229 0 10.000000 -230 0 10.000000 -231 0 10.000000 -232 0 10.000000 -233 0 10.000000 -234 0 10.000000 -235 0 10.000000 -236 0 10.000000 -237 0 10.000000 -238 0 10.000000 -239 0 10.000000 -240 0 10.000000 -241 0 10.000000 -242 0 10.000000 -243 0 10.000000 -244 0 10.000000 -245 0 10.000000 -246 0 10.000000 -247 0 10.000000 -248 0 10.000000 -249 0 10.000000 -250 0 10.000000 -251 0 10.000000 -252 0 10.000000 -253 0 10.000000 -254 0 10.000000 -255 0 10.000000 -256 0 10.000000 -257 0 10.000000 -258 0 10.000000 -259 0 10.000000 -260 0 10.000000 -261 0 10.000000 -262 0 10.000000 -263 0 10.000000 -264 0 10.000000 -265 0 10.000000 -266 0 10.000000 -267 0 10.000000 -268 0 10.000000 -269 0 10.000000 -270 0 10.000000 -271 0 10.000000 -272 0 10.000000 -273 0 10.000000 -274 0 10.000000 -275 0 10.000000 -276 0 10.000000 -277 0 10.000000 -278 0 10.000000 -279 0 10.000000 -280 0 10.000000 -281 0 10.000000 -282 0 10.000000 -283 0 10.000000 -284 0 10.000000 -285 0 10.000000 -286 0 10.000000 -287 0 10.000000 -288 0 10.000000 -289 0 10.000000 -290 0 10.000000 -291 0 10.000000 -292 0 10.000000 -293 0 10.000000 -294 0 10.000000 -295 0 10.000000 -296 0 10.000000 -297 0 10.000000 -298 0 10.000000 -299 0 10.000000 -300 0 10.000000 -301 0 10.000000 -302 0 10.000000 -303 0 10.000000 -304 0 10.000000 -305 0 10.000000 -306 0 10.000000 -307 0 10.000000 -308 0 10.000000 -309 0 10.000000 -310 0 10.000000 -311 0 10.000000 -312 0 10.000000 -313 0 10.000000 -314 0 10.000000 -315 0 10.000000 -316 0 10.000000 -317 0 10.000000 -318 0 10.000000 -319 0 10.000000 -320 0 10.000000 -321 0 10.000000 -322 0 10.000000 -323 0 10.000000 -324 0 10.000000 -325 0 10.000000 -326 0 10.000000 -327 0 10.000000 -328 0 10.000000 -329 0 10.000000 -330 0 10.000000 -331 0 10.000000 -332 0 10.000000 -333 0 10.000000 -334 0 10.000000 -335 0 10.000000 -336 0 10.000000 -337 0 10.000000 -338 0 10.000000 -339 0 10.000000 -340 0 10.000000 -341 0 10.000000 -342 0 10.000000 -343 0 10.000000 -344 0 10.000000 -345 0 10.000000 -346 0 10.000000 -347 0 10.000000 -348 0 10.000000 -349 0 10.000000 -350 0 10.000000 -351 0 10.000000 -352 0 10.000000 -353 0 10.000000 -354 0 10.000000 -355 0 10.000000 -356 0 10.000000 -357 0 10.000000 -358 0 10.000000 -359 0 10.000000 -360 0 10.000000 -361 0 10.000000 -362 0 10.000000 -363 0 10.000000 -364 0 10.000000 -365 0 10.000000 -366 0 10.000000 -367 0 10.000000 -368 0 10.000000 -369 0 10.000000 -370 0 10.000000 -371 0 10.000000 -372 0 10.000000 -373 0 10.000000 -374 0 10.000000 -375 0 10.000000 -376 0 10.000000 -377 0 10.000000 -378 0 10.000000 -379 0 10.000000 -380 0 10.000000 -381 0 10.000000 -382 0 10.000000 -383 0 10.000000 -384 0 10.000000 -385 0 10.000000 -386 0 10.000000 -387 0 10.000000 -388 0 10.000000 -389 0 10.000000 -390 0 10.000000 -391 0 10.000000 -392 0 10.000000 -393 0 10.000000 -394 0 10.000000 -395 0 10.000000 -396 0 10.000000 -397 0 10.000000 -398 0 10.000000 -399 0 10.000000 -400 0 10.000000 -401 0 10.000000 -402 0 10.000000 -403 0 10.000000 -404 0 10.000000 -405 0 10.000000 -406 0 10.000000 -407 0 10.000000 -408 0 10.000000 -409 0 10.000000 -410 0 10.000000 -411 0 10.000000 -412 0 10.000000 -413 0 10.000000 -414 0 10.000000 -415 0 10.000000 -416 0 10.000000 -417 0 10.000000 -418 0 10.000000 -419 0 10.000000 -420 0 10.000000 -421 0 10.000000 -422 0 10.000000 -423 0 10.000000 -424 0 10.000000 -425 0 10.000000 -426 0 10.000000 -427 0 10.000000 -428 0 10.000000 -429 0 10.000000 -430 0 10.000000 -431 0 10.000000 -432 0 10.000000 -433 0 10.000000 -434 0 10.000000 -435 0 10.000000 -436 0 10.000000 -437 0 10.000000 -438 0 10.000000 -439 0 10.000000 -440 0 10.000000 -441 0 10.000000 -442 0 10.000000 -443 0 10.000000 -444 0 10.000000 -445 0 10.000000 -446 0 10.000000 -447 0 10.000000 -448 0 10.000000 -449 0 10.000000 -450 0 10.000000 -451 0 10.000000 -452 0 10.000000 -453 0 10.000000 -454 0 10.000000 -455 0 10.000000 -456 0 10.000000 -457 0 10.000000 -458 0 10.000000 -459 0 10.000000 -460 0 10.000000 -461 0 10.000000 -462 0 10.000000 -463 0 10.000000 -464 0 10.000000 -465 0 10.000000 -466 0 10.000000 -467 0 10.000000 -468 0 10.000000 -469 0 10.000000 -470 0 10.000000 -471 0 10.000000 -472 0 10.000000 -473 0 10.000000 -474 0 10.000000 -475 0 10.000000 -476 0 10.000000 -477 0 10.000000 -478 0 10.000000 -479 0 10.000000 -480 0 10.000000 -481 0 10.000000 -482 0 10.000000 -483 0 10.000000 -484 0 10.000000 -485 0 10.000000 -486 0 10.000000 -487 0 10.000000 -488 0 10.000000 -489 0 10.000000 -490 0 10.000000 -491 0 10.000000 -492 0 10.000000 -493 0 10.000000 -494 0 10.000000 -495 0 10.000000 -496 0 10.000000 -497 0 10.000000 -498 0 10.000000 -499 0 10.000000 -500 0 10.000000 -501 0 10.000000 -502 0 10.000000 -503 0 10.000000 -504 0 10.000000 -505 0 10.000000 -506 0 10.000000 -507 0 10.000000 -508 0 10.000000 -509 0 10.000000 -510 0 10.000000 -511 0 10.000000 -512 0 10.000000 -513 0 10.000000 -514 0 10.000000 -515 0 10.000000 -516 0 10.000000 -517 0 10.000000 -518 0 10.000000 -519 0 10.000000 -520 0 10.000000 -521 0 10.000000 -522 0 10.000000 -523 0 10.000000 -524 0 10.000000 -525 0 10.000000 -526 0 10.000000 -527 0 10.000000 -528 0 10.000000 -529 0 10.000000 -530 0 10.000000 -531 0 10.000000 -532 0 10.000000 -533 0 10.000000 -534 0 10.000000 -535 0 10.000000 -536 0 10.000000 -537 0 10.000000 -538 0 10.000000 -539 0 10.000000 -540 0 10.000000 -541 0 10.000000 -542 0 10.000000 -543 0 10.000000 -544 0 10.000000 -545 0 10.000000 -546 0 10.000000 -547 0 10.000000 -548 0 10.000000 -549 0 10.000000 -550 0 10.000000 -551 0 10.000000 -552 0 10.000000 -553 0 10.000000 -554 0 10.000000 -555 0 10.000000 -556 0 10.000000 -557 0 10.000000 -558 0 10.000000 -559 0 10.000000 -560 0 10.000000 -561 0 10.000000 -562 0 10.000000 -563 0 10.000000 -564 0 10.000000 -565 0 10.000000 -566 0 10.000000 -567 0 10.000000 -568 0 10.000000 -569 0 10.000000 -570 0 10.000000 -571 0 10.000000 -572 0 10.000000 -573 0 10.000000 -574 0 10.000000 -575 0 10.000000 -576 0 10.000000 -577 0 10.000000 -578 0 10.000000 -579 0 10.000000 -580 0 10.000000 -581 0 10.000000 -582 0 10.000000 -583 0 10.000000 -584 0 10.000000 -585 0 10.000000 -586 0 10.000000 -587 0 10.000000 -588 0 10.000000 -589 0 10.000000 -590 0 10.000000 -591 0 10.000000 -592 0 10.000000 -593 0 10.000000 -594 0 10.000000 -595 0 10.000000 -596 0 10.000000 -597 0 10.000000 -598 0 10.000000 -599 0 10.000000 -600 0 10.000000 -601 0 10.000000 -602 0 10.000000 -603 0 10.000000 -604 0 10.000000 -605 0 10.000000 -606 0 10.000000 -607 0 10.000000 -608 0 10.000000 -609 0 10.000000 -610 0 10.000000 -611 0 10.000000 -612 0 10.000000 -613 0 10.000000 -614 0 10.000000 -615 0 10.000000 -616 0 10.000000 -617 0 10.000000 -618 0 10.000000 -619 0 10.000000 -620 0 10.000000 -621 0 10.000000 -622 0 10.000000 -623 0 10.000000 -624 0 10.000000 -625 0 10.000000 -626 0 10.000000 -627 0 10.000000 -628 0 10.000000 -629 0 10.000000 -630 0 10.000000 -631 0 10.000000 -632 0 10.000000 -633 0 10.000000 -634 0 10.000000 -635 0 10.000000 -636 0 10.000000 -637 0 10.000000 -638 0 10.000000 -639 0 10.000000 -640 0 10.000000 -641 0 10.000000 -642 0 10.000000 -643 0 10.000000 -644 0 10.000000 -645 0 10.000000 -646 0 10.000000 -647 0 10.000000 -648 0 10.000000 -649 0 10.000000 -650 0 10.000000 -651 0 10.000000 -652 0 10.000000 -653 0 10.000000 -654 0 10.000000 -655 0 10.000000 -656 0 10.000000 -657 0 10.000000 -658 0 10.000000 -659 0 10.000000 -660 0 10.000000 -661 0 10.000000 -662 0 10.000000 -663 0 10.000000 -664 0 10.000000 -665 0 10.000000 -666 0 10.000000 -667 0 10.000000 -668 0 10.000000 -669 0 10.000000 -670 0 10.000000 -671 0 10.000000 -672 0 10.000000 -673 0 10.000000 -674 0 10.000000 -675 0 10.000000 -676 0 10.000000 -677 0 10.000000 -678 0 10.000000 -679 0 10.000000 -680 0 10.000000 -681 0 10.000000 -682 0 10.000000 -683 0 10.000000 -684 0 10.000000 -685 0 10.000000 -686 0 10.000000 -687 0 10.000000 -688 0 10.000000 -689 0 10.000000 -690 0 10.000000 -691 0 10.000000 -692 0 10.000000 -693 0 10.000000 -694 0 10.000000 -695 0 10.000000 -696 0 10.000000 -697 0 10.000000 -698 0 10.000000 -699 0 10.000000 -700 0 10.000000 -701 0 10.000000 -702 0 10.000000 -703 0 10.000000 -704 0 10.000000 -705 0 10.000000 -706 0 10.000000 -707 0 10.000000 -708 0 10.000000 -709 0 10.000000 -710 0 10.000000 -711 0 10.000000 -712 0 10.000000 -713 0 10.000000 -714 0 10.000000 -715 0 10.000000 -716 0 10.000000 -717 0 10.000000 -718 0 10.000000 -719 0 10.000000 -720 0 10.000000 -721 0 10.000000 -722 0 10.000000 -723 0 10.000000 -724 0 10.000000 -725 0 10.000000 -726 0 10.000000 -727 0 10.000000 -728 0 10.000000 -729 0 10.000000 -730 0 10.000000 -731 0 10.000000 -732 0 10.000000 -733 0 10.000000 -734 0 10.000000 -735 0 10.000000 -736 0 10.000000 -737 0 10.000000 -738 0 10.000000 -739 0 10.000000 -740 0 10.000000 -741 0 10.000000 -742 0 10.000000 -743 0 10.000000 -744 0 10.000000 -745 0 10.000000 -746 0 10.000000 -747 0 10.000000 -748 0 10.000000 -749 0 10.000000 -750 0 10.000000 -751 0 10.000000 -752 0 10.000000 -753 0 10.000000 -754 0 10.000000 -755 0 10.000000 -756 0 10.000000 -757 0 10.000000 -758 0 10.000000 -759 0 10.000000 -760 0 10.000000 -761 0 10.000000 -762 0 10.000000 -763 0 10.000000 -764 0 10.000000 -765 0 10.000000 -766 0 10.000000 -767 0 10.000000 -768 0 10.000000 -769 0 10.000000 -770 0 10.000000 -771 0 10.000000 -772 0 10.000000 -773 0 10.000000 -774 0 10.000000 -775 0 10.000000 -776 0 10.000000 -777 0 10.000000 -778 0 10.000000 -779 0 10.000000 -780 0 10.000000 -781 0 10.000000 -782 0 10.000000 -783 0 10.000000 -784 0 10.000000 -785 0 10.000000 -786 0 10.000000 -787 0 10.000000 -788 0 10.000000 -789 0 10.000000 -790 0 10.000000 -791 0 10.000000 -792 0 10.000000 -793 0 10.000000 -794 0 10.000000 -795 0 10.000000 -796 0 10.000000 -797 0 10.000000 -798 0 10.000000 -799 0 10.000000 -800 0 10.000000 -801 0 10.000000 -802 0 10.000000 -803 0 10.000000 -804 0 10.000000 -805 0 10.000000 -806 0 10.000000 -807 0 10.000000 -808 0 10.000000 -809 0 10.000000 -810 0 10.000000 -811 0 10.000000 -812 0 10.000000 -813 0 10.000000 -814 0 10.000000 -815 0 10.000000 -816 0 10.000000 -817 0 10.000000 -818 0 10.000000 -819 0 10.000000 -820 0 10.000000 -821 0 10.000000 -822 0 10.000000 -823 0 10.000000 -824 0 10.000000 -825 0 10.000000 -826 0 10.000000 -827 0 10.000000 -828 0 10.000000 -829 0 10.000000 -830 0 10.000000 -831 0 10.000000 -832 0 10.000000 -833 0 10.000000 -834 0 10.000000 -835 0 10.000000 -836 0 10.000000 -837 0 10.000000 -838 0 10.000000 -839 0 10.000000 -840 0 10.000000 -841 0 10.000000 -842 0 10.000000 -843 0 10.000000 -844 0 10.000000 -845 0 10.000000 -846 0 10.000000 -847 0 10.000000 -848 0 10.000000 -849 0 10.000000 -850 0 10.000000 -851 0 10.000000 -852 0 10.000000 -853 0 10.000000 -854 0 10.000000 -855 0 10.000000 -856 0 10.000000 -857 0 10.000000 -858 0 10.000000 -859 0 10.000000 -860 0 10.000000 -861 0 10.000000 -862 0 10.000000 -863 0 10.000000 -864 0 10.000000 -865 0 10.000000 -866 0 10.000000 -867 0 10.000000 -868 0 10.000000 -869 0 10.000000 -870 0 10.000000 -871 0 10.000000 -872 0 10.000000 -873 0 10.000000 -874 0 10.000000 -875 0 10.000000 -876 0 10.000000 -877 0 10.000000 -878 0 10.000000 -879 0 10.000000 -880 0 10.000000 -881 0 10.000000 -882 0 10.000000 -883 0 10.000000 -884 0 10.000000 -885 0 10.000000 -886 0 10.000000 -887 0 10.000000 -888 0 10.000000 -889 0 10.000000 -890 0 10.000000 -891 0 10.000000 -892 0 10.000000 -893 0 10.000000 -894 0 10.000000 -895 0 10.000000 -896 0 10.000000 -897 0 10.000000 -898 0 10.000000 -899 0 10.000000 -900 0 10.000000 -901 0 10.000000 -902 0 10.000000 -903 0 10.000000 -904 0 10.000000 -905 0 10.000000 -906 0 10.000000 -907 0 10.000000 -908 0 10.000000 -909 0 10.000000 -910 0 10.000000 -911 0 10.000000 -912 0 10.000000 -913 0 10.000000 -914 0 10.000000 -915 0 10.000000 -916 0 10.000000 -917 0 10.000000 -918 0 10.000000 -919 0 10.000000 -920 0 10.000000 -921 0 10.000000 -922 0 10.000000 -923 0 10.000000 -924 0 10.000000 -925 0 10.000000 -926 0 10.000000 -927 0 10.000000 -928 0 10.000000 -929 0 10.000000 -930 0 10.000000 -931 0 10.000000 -932 0 10.000000 -933 0 10.000000 -934 0 10.000000 -935 0 10.000000 -936 0 10.000000 -937 0 10.000000 -938 0 10.000000 -939 0 10.000000 -940 0 10.000000 -941 0 10.000000 -942 0 10.000000 -943 0 10.000000 -944 0 10.000000 -945 0 10.000000 -946 0 10.000000 -947 0 10.000000 -948 0 10.000000 -949 0 10.000000 -950 0 10.000000 -951 0 10.000000 -952 0 10.000000 -953 0 10.000000 -954 0 10.000000 -955 0 10.000000 -956 0 10.000000 -957 0 10.000000 -958 0 10.000000 -959 0 10.000000 -960 0 10.000000 -961 0 10.000000 -962 0 10.000000 -963 0 10.000000 -964 0 10.000000 -965 0 10.000000 -966 0 10.000000 -967 0 10.000000 -968 0 10.000000 -969 0 10.000000 -970 0 10.000000 -971 0 10.000000 -972 0 10.000000 -973 0 10.000000 -974 0 10.000000 -975 0 10.000000 -976 0 10.000000 -977 0 10.000000 -978 0 10.000000 -979 0 10.000000 -980 0 10.000000 -981 0 10.000000 -982 0 10.000000 -983 0 10.000000 -984 0 10.000000 -985 0 10.000000 -986 0 10.000000 -987 0 10.000000 -988 0 10.000000 -989 0 10.000000 -990 0 10.000000 -991 0 10.000000 -992 0 10.000000 -993 0 10.000000 -994 0 10.000000 -995 0 10.000000 -996 0 10.000000 -997 0 10.000000 -998 0 10.000000 -999 0 10.000000 -1000 0 10.000000 -1001 0 10.000000 -1002 0 10.000000 -1003 0 10.000000 -1004 0 10.000000 -1005 0 10.000000 -1006 0 10.000000 -1007 0 10.000000 -1008 0 10.000000 -1009 0 10.000000 -1010 0 10.000000 -1011 0 10.000000 -1012 0 10.000000 -1013 0 10.000000 -1014 0 10.000000 -1015 0 10.000000 -1016 0 10.000000 -1017 0 10.000000 -1018 0 10.000000 -1019 0 10.000000 -1020 0 10.000000 -1021 0 10.000000 -1022 0 10.000000 -1023 0 10.000000 -1024 0 10.000000 -1025 0 10.000000 -1026 0 10.000000 -1027 0 10.000000 -1028 0 10.000000 -1029 0 10.000000 -1030 0 10.000000 -1031 0 10.000000 -1032 0 10.000000 -1033 0 10.000000 -1034 0 10.000000 -1035 0 10.000000 -1036 0 10.000000 -1037 0 10.000000 -1038 0 10.000000 -1039 0 10.000000 -1040 0 10.000000 -1041 0 10.000000 -1042 0 10.000000 -1043 0 10.000000 -1044 0 10.000000 -1045 0 10.000000 -1046 0 10.000000 -1047 0 10.000000 -1048 0 10.000000 -1049 0 10.000000 -1050 0 10.000000 -1051 0 10.000000 -1052 0 10.000000 -1053 0 10.000000 -1054 0 10.000000 -1055 0 10.000000 -1056 0 10.000000 -1057 0 10.000000 -1058 0 10.000000 -1059 0 10.000000 -1060 0 10.000000 -1061 0 10.000000 -1062 0 10.000000 -1063 0 10.000000 -1064 0 10.000000 -1065 0 10.000000 -1066 0 10.000000 -1067 0 10.000000 -1068 0 10.000000 -1069 0 10.000000 -1070 0 10.000000 -1071 0 10.000000 -1072 0 10.000000 -1073 0 10.000000 -1074 0 10.000000 -1075 0 10.000000 -1076 0 10.000000 -1077 0 10.000000 -1078 0 10.000000 -1079 0 10.000000 -1080 0 10.000000 -1081 0 10.000000 -1082 0 10.000000 -1083 0 10.000000 -1084 0 10.000000 -1085 0 10.000000 -1086 0 10.000000 -1087 0 10.000000 -1088 0 10.000000 -1089 0 10.000000 -1090 0 10.000000 -1091 0 10.000000 -1092 0 10.000000 -1093 0 10.000000 -1094 0 10.000000 -1095 0 10.000000 -1096 0 10.000000 -1097 0 10.000000 -1098 0 10.000000 -1099 0 10.000000 -1100 0 10.000000 -1101 0 10.000000 -1102 0 10.000000 -1103 0 10.000000 -1104 0 10.000000 -1105 0 10.000000 -1106 0 10.000000 -1107 0 10.000000 -1108 0 10.000000 -1109 0 10.000000 -1110 0 10.000000 -1111 0 10.000000 -1112 0 10.000000 -1113 0 10.000000 -1114 0 10.000000 -1115 0 10.000000 -1116 0 10.000000 -1117 0 10.000000 -1118 0 10.000000 -1119 0 10.000000 -1120 0 10.000000 -1121 0 10.000000 -1122 0 10.000000 -1123 0 10.000000 -1124 0 10.000000 -1125 0 10.000000 -1126 0 10.000000 -1127 0 10.000000 -1128 0 10.000000 -1129 0 10.000000 -1130 0 10.000000 -1131 0 10.000000 -1132 0 10.000000 -1133 0 10.000000 -1134 0 10.000000 -1135 0 10.000000 -1136 0 10.000000 -1137 0 10.000000 -1138 0 10.000000 -1139 0 10.000000 -1140 0 10.000000 -1141 0 10.000000 -1142 0 10.000000 -1143 0 10.000000 -1144 0 10.000000 -1145 0 10.000000 -1146 0 10.000000 -1147 0 10.000000 -1148 0 10.000000 -1149 0 10.000000 -1150 0 10.000000 -1151 0 10.000000 -1152 0 10.000000 -1153 0 10.000000 -1154 0 10.000000 -1155 0 10.000000 -1156 0 10.000000 -1157 0 10.000000 -1158 0 10.000000 -1159 0 10.000000 -1160 0 10.000000 -1161 0 10.000000 -1162 0 10.000000 -1163 0 10.000000 -1164 0 10.000000 -1165 0 10.000000 -1166 0 10.000000 -1167 0 10.000000 -1168 0 10.000000 -1169 0 10.000000 -1170 0 10.000000 -1171 0 10.000000 -1172 0 10.000000 -1173 0 10.000000 -1174 0 10.000000 -1175 0 10.000000 -1176 0 10.000000 -1177 0 10.000000 -1178 0 10.000000 -1179 0 10.000000 -1180 0 10.000000 -1181 0 10.000000 -1182 0 10.000000 -1183 0 10.000000 -1184 0 10.000000 -1185 0 10.000000 -1186 0 10.000000 -1187 0 10.000000 -1188 0 10.000000 -1189 0 10.000000 -1190 0 10.000000 -1191 0 10.000000 -1192 0 10.000000 -1193 0 10.000000 -1194 0 10.000000 -1195 0 10.000000 -1196 0 10.000000 -1197 0 10.000000 -1198 0 10.000000 -1199 0 10.000000 -1200 0 10.000000 -1201 0 10.000000 -1202 0 10.000000 -1203 0 10.000000 -1204 0 10.000000 -1205 0 10.000000 -1206 0 10.000000 -1207 0 10.000000 -1208 0 10.000000 -1209 0 10.000000 -1210 0 10.000000 -1211 0 10.000000 -1212 0 10.000000 -1213 0 10.000000 -1214 0 10.000000 -1215 0 10.000000 -1216 0 10.000000 -1217 0 10.000000 -1218 0 10.000000 -1219 0 10.000000 -1220 0 10.000000 -1221 0 10.000000 -1222 0 10.000000 -1223 0 10.000000 -1224 0 10.000000 -1225 0 10.000000 -1226 0 10.000000 -1227 0 10.000000 -1228 0 10.000000 -1229 0 10.000000 -1230 0 10.000000 -1231 0 10.000000 -1232 0 10.000000 -1233 0 10.000000 -1234 0 10.000000 -1235 0 10.000000 -1236 0 10.000000 -1237 0 10.000000 -1238 0 10.000000 -1239 0 10.000000 -1240 0 10.000000 -1241 0 10.000000 -1242 0 10.000000 -1243 0 10.000000 -1244 0 10.000000 -1245 0 10.000000 -1246 0 10.000000 -1247 0 10.000000 -1248 0 10.000000 -1249 0 10.000000 -1250 0 10.000000 -1251 0 10.000000 -1252 0 10.000000 -1253 0 10.000000 -1254 0 10.000000 -1255 0 10.000000 -1256 0 10.000000 -1257 0 10.000000 -1258 0 10.000000 -1259 0 10.000000 -1260 0 10.000000 -1261 0 10.000000 -1262 0 10.000000 -1263 0 10.000000 -1264 0 10.000000 -1265 0 10.000000 -1266 0 10.000000 -1267 0 10.000000 -1268 0 10.000000 -1269 0 10.000000 -1270 0 10.000000 -1271 0 10.000000 -1272 0 10.000000 -1273 0 10.000000 -1274 0 10.000000 -1275 0 10.000000 -1276 0 10.000000 -1277 0 10.000000 -1278 0 10.000000 -1279 0 10.000000 -1280 0 10.000000 -1281 0 10.000000 -1282 0 10.000000 -1283 0 10.000000 -1284 0 10.000000 -1285 0 10.000000 -1286 0 10.000000 -1287 0 10.000000 -1288 0 10.000000 -1289 0 10.000000 -1290 0 10.000000 -1291 0 10.000000 -1292 0 10.000000 -1293 0 10.000000 -1294 0 10.000000 -1295 0 10.000000 -1296 0 10.000000 -1297 0 10.000000 -1298 0 10.000000 -1299 0 10.000000 -1300 0 10.000000 -1301 0 10.000000 -1302 0 10.000000 -1303 0 10.000000 -1304 0 10.000000 -1305 0 10.000000 -1306 0 10.000000 -1307 0 10.000000 -1308 0 10.000000 -1309 0 10.000000 -1310 0 10.000000 -1311 0 10.000000 -1312 0 10.000000 -1313 0 10.000000 -1314 0 10.000000 -1315 0 10.000000 -1316 0 10.000000 -1317 0 10.000000 -1318 0 10.000000 -1319 0 10.000000 -1320 0 10.000000 -1321 0 10.000000 -1322 0 10.000000 -1323 0 10.000000 -1324 0 10.000000 -1325 0 10.000000 -1326 0 10.000000 -1327 0 10.000000 -1328 0 10.000000 -1329 0 10.000000 -1330 0 10.000000 -1331 0 10.000000 -1332 0 10.000000 -1333 0 10.000000 -1334 0 10.000000 -1335 0 10.000000 -1336 0 10.000000 -1337 0 10.000000 -1338 0 10.000000 -1339 0 10.000000 -1340 0 10.000000 -1341 0 10.000000 -1342 0 10.000000 -1343 0 10.000000 -1344 0 10.000000 -1345 0 10.000000 -1346 0 10.000000 -1347 0 10.000000 -1348 0 10.000000 -1349 0 10.000000 -1350 0 10.000000 -1351 0 10.000000 -1352 0 10.000000 -1353 0 10.000000 -1354 0 10.000000 -1355 0 10.000000 -1356 0 10.000000 -1357 0 10.000000 -1358 0 10.000000 -1359 0 10.000000 -1360 0 10.000000 -1361 0 10.000000 -1362 0 10.000000 -1363 0 10.000000 -1364 0 10.000000 -1365 0 10.000000 -1366 0 10.000000 -1367 0 10.000000 -1368 0 10.000000 -1369 0 10.000000 -1370 0 10.000000 -1371 0 10.000000 -1372 0 10.000000 -1373 0 10.000000 -1374 0 10.000000 -1375 0 10.000000 -1376 0 10.000000 -1377 0 10.000000 -1378 0 10.000000 -1379 0 10.000000 -1380 0 10.000000 -1381 0 10.000000 -1382 0 10.000000 -1383 0 10.000000 -1384 0 10.000000 -1385 0 10.000000 -1386 0 10.000000 -1387 0 10.000000 -1388 0 10.000000 -1389 0 10.000000 -1390 0 10.000000 -1391 0 10.000000 -1392 0 10.000000 -1393 0 10.000000 -1394 0 10.000000 -1395 0 10.000000 -1396 0 10.000000 -1397 0 10.000000 -1398 0 10.000000 -1399 0 10.000000 -1400 0 10.000000 -1401 0 10.000000 -1402 0 10.000000 -1403 0 10.000000 -1404 0 10.000000 -1405 0 10.000000 -1406 0 10.000000 -1407 0 10.000000 -1408 0 10.000000 -1409 0 10.000000 -1410 0 10.000000 -1411 0 10.000000 -1412 0 10.000000 -1413 0 10.000000 -1414 0 10.000000 -1415 0 10.000000 -1416 0 10.000000 -1417 0 10.000000 -1418 0 10.000000 -1419 0 10.000000 -1420 0 10.000000 -1421 0 10.000000 -1422 0 10.000000 -1423 0 10.000000 -1424 0 10.000000 -1425 0 10.000000 -1426 0 10.000000 -1427 0 10.000000 -1428 0 10.000000 -1429 0 10.000000 -1430 0 10.000000 -1431 0 10.000000 -1432 0 10.000000 -1433 0 10.000000 -1434 0 10.000000 -1435 0 10.000000 -1436 0 10.000000 -1437 0 10.000000 -1438 0 10.000000 -1439 0 10.000000 -1440 0 10.000000 -1441 0 10.000000 -1442 0 10.000000 -1443 0 10.000000 -1444 0 10.000000 -1445 0 10.000000 -1446 0 10.000000 -1447 0 10.000000 -1448 0 10.000000 -1449 0 10.000000 -1450 0 10.000000 -1451 0 10.000000 -1452 0 10.000000 -1453 0 10.000000 -1454 0 10.000000 -1455 0 10.000000 -1456 0 10.000000 -1457 0 10.000000 -1458 0 10.000000 -1459 0 10.000000 -1460 0 10.000000 -1461 0 10.000000 -1462 0 10.000000 -1463 0 10.000000 -1464 0 10.000000 -1465 0 10.000000 -1466 0 10.000000 -1467 0 10.000000 -1468 0 10.000000 -1469 0 10.000000 -1470 0 10.000000 -1471 0 10.000000 -1472 0 10.000000 -1473 0 10.000000 -1474 0 10.000000 -1475 0 10.000000 -1476 0 10.000000 -1477 0 10.000000 -1478 0 10.000000 -1479 0 10.000000 -1480 0 10.000000 -1481 0 10.000000 -1482 0 10.000000 -1483 0 10.000000 -1484 0 10.000000 -1485 0 10.000000 -1486 0 10.000000 -1487 0 10.000000 -1488 0 10.000000 -1489 0 10.000000 -1490 0 10.000000 -1491 0 10.000000 -1492 0 10.000000 -1493 0 10.000000 -1494 0 10.000000 -1495 0 10.000000 -1496 0 10.000000 -1497 0 10.000000 -1498 0 10.000000 -1499 0 10.000000 -1500 0 10.000000 -1501 0 10.000000 -1502 0 10.000000 -1503 0 10.000000 -1504 0 10.000000 -1505 0 10.000000 -1506 0 10.000000 -1507 0 10.000000 -1508 0 10.000000 -1509 0 10.000000 -1510 0 10.000000 -1511 0 10.000000 -1512 0 10.000000 -1513 0 10.000000 -1514 0 10.000000 -1515 0 10.000000 -1516 0 10.000000 -1517 0 10.000000 -1518 0 10.000000 -1519 0 10.000000 -1520 0 10.000000 -1521 0 10.000000 -1522 0 10.000000 -1523 0 10.000000 -1524 0 10.000000 -1525 0 10.000000 -1526 0 10.000000 -1527 0 10.000000 -1528 0 10.000000 -1529 0 10.000000 -1530 0 10.000000 -1531 0 10.000000 -1532 0 10.000000 -1533 0 10.000000 -1534 0 10.000000 -1535 0 10.000000 -1536 0 10.000000 -1537 0 10.000000 -1538 0 10.000000 -1539 0 10.000000 -1540 0 10.000000 -1541 0 10.000000 -1542 0 10.000000 -1543 0 10.000000 -1544 0 10.000000 -1545 0 10.000000 -1546 0 10.000000 -1547 0 10.000000 -1548 0 10.000000 -1549 0 10.000000 -1550 0 10.000000 -1551 0 10.000000 -1552 0 10.000000 -1553 0 10.000000 -1554 0 10.000000 -1555 0 10.000000 -1556 0 10.000000 -1557 0 10.000000 -1558 0 10.000000 -1559 0 10.000000 -1560 0 10.000000 -1561 0 10.000000 -1562 0 10.000000 -1563 0 10.000000 -1564 0 10.000000 -1565 0 10.000000 -1566 0 10.000000 -1567 0 10.000000 -1568 0 10.000000 -1569 0 10.000000 -1570 0 10.000000 -1571 0 10.000000 -1572 0 10.000000 -1573 0 10.000000 -1574 0 10.000000 -1575 0 10.000000 -1576 0 10.000000 -1577 0 10.000000 -1578 0 10.000000 -1579 0 10.000000 -1580 0 10.000000 -1581 0 10.000000 -1582 0 10.000000 -1583 0 10.000000 -1584 0 10.000000 -1585 0 10.000000 -1586 0 10.000000 -1587 0 10.000000 -1588 0 10.000000 -1589 0 10.000000 -1590 0 10.000000 -1591 0 10.000000 -1592 0 10.000000 -1593 0 10.000000 -1594 0 10.000000 -1595 0 10.000000 -1596 0 10.000000 -1597 0 10.000000 -1598 0 10.000000 -1599 0 10.000000 -1600 0 10.000000 -1601 0 10.000000 -1602 0 10.000000 -1603 0 10.000000 -1604 0 10.000000 -1605 0 10.000000 -1606 0 10.000000 -1607 0 10.000000 -1608 0 10.000000 -1609 0 10.000000 -1610 0 10.000000 -1611 0 10.000000 -1612 0 10.000000 -1613 0 10.000000 -1614 0 10.000000 -1615 0 10.000000 -1616 0 10.000000 -1617 0 10.000000 -1618 0 10.000000 -1619 0 10.000000 -1620 0 10.000000 -1621 0 10.000000 -1622 0 10.000000 -1623 0 10.000000 -1624 0 10.000000 -1625 0 10.000000 -1626 0 10.000000 -1627 0 10.000000 -1628 0 10.000000 -1629 0 10.000000 -1630 0 10.000000 -1631 0 10.000000 -1632 0 10.000000 -1633 0 10.000000 -1634 0 10.000000 -1635 0 10.000000 -1636 0 10.000000 -1637 0 10.000000 -1638 0 10.000000 -1639 0 10.000000 -1640 0 10.000000 -1641 0 10.000000 -1642 0 10.000000 -1643 0 10.000000 -1644 0 10.000000 -1645 0 10.000000 -1646 0 10.000000 -1647 0 10.000000 -1648 0 10.000000 -1649 0 10.000000 -1650 0 10.000000 -1651 0 10.000000 -1652 0 10.000000 -1653 0 10.000000 -1654 0 10.000000 -1655 0 10.000000 -1656 0 10.000000 -1657 0 10.000000 -1658 0 10.000000 -1659 0 10.000000 -1660 0 10.000000 -1661 0 10.000000 -1662 0 10.000000 -1663 0 10.000000 -1664 0 10.000000 -1665 0 10.000000 -1666 0 10.000000 -1667 0 10.000000 -1668 0 10.000000 -1669 0 10.000000 -1670 0 10.000000 -1671 0 10.000000 -1672 0 10.000000 -1673 0 10.000000 -1674 0 10.000000 -1675 0 10.000000 -1676 0 10.000000 -1677 0 10.000000 -1678 0 10.000000 -1679 0 10.000000 -1680 0 10.000000 -1681 0 10.000000 -1682 0 10.000000 -1683 0 10.000000 -1684 0 10.000000 -1685 0 10.000000 -1686 0 10.000000 -1687 0 10.000000 -1688 0 10.000000 -1689 0 10.000000 -1690 0 10.000000 -1691 0 10.000000 -1692 0 10.000000 -1693 0 10.000000 -1694 0 10.000000 -1695 0 10.000000 -1696 0 10.000000 -1697 0 10.000000 -1698 0 10.000000 -1699 0 10.000000 -1700 0 10.000000 -1701 0 10.000000 -1702 0 10.000000 -1703 0 10.000000 -1704 0 10.000000 -1705 0 10.000000 -1706 0 10.000000 -1707 0 10.000000 -1708 0 10.000000 -1709 0 10.000000 -1710 0 10.000000 -1711 0 10.000000 -1712 0 10.000000 -1713 0 10.000000 -1714 0 10.000000 -1715 0 10.000000 -1716 0 10.000000 -1717 0 10.000000 -1718 0 10.000000 -1719 0 10.000000 -1720 0 10.000000 -1721 0 10.000000 -1722 0 10.000000 -1723 0 10.000000 -1724 0 10.000000 -1725 0 10.000000 -1726 0 10.000000 -1727 0 10.000000 -1728 0 10.000000 -1729 0 10.000000 -1730 0 10.000000 -1731 0 10.000000 -1732 0 10.000000 -1733 0 10.000000 -1734 0 10.000000 -1735 0 10.000000 -1736 0 10.000000 -1737 0 10.000000 -1738 0 10.000000 -1739 0 10.000000 -1740 0 10.000000 -1741 0 10.000000 -1742 0 10.000000 -1743 0 10.000000 -1744 0 10.000000 -1745 0 10.000000 -1746 0 10.000000 -1747 0 10.000000 -1748 0 10.000000 -1749 0 10.000000 -1750 0 10.000000 -1751 0 10.000000 -1752 0 10.000000 -1753 0 10.000000 -1754 0 10.000000 -1755 0 10.000000 -1756 0 10.000000 -1757 0 10.000000 -1758 0 10.000000 -1759 0 10.000000 -1760 0 10.000000 -1761 0 10.000000 -1762 0 10.000000 -1763 0 10.000000 -1764 0 10.000000 -1765 0 10.000000 -1766 0 10.000000 -1767 0 10.000000 -1768 0 10.000000 -1769 0 10.000000 -1770 0 10.000000 -1771 0 10.000000 -1772 0 10.000000 -1773 0 10.000000 -1774 0 10.000000 -1775 0 10.000000 -1776 0 10.000000 -1777 0 10.000000 -1778 0 10.000000 -1779 0 10.000000 -1780 0 10.000000 -1781 0 10.000000 -1782 0 10.000000 -1783 0 10.000000 -1784 0 10.000000 -1785 0 10.000000 -1786 0 10.000000 -1787 0 10.000000 -1788 0 10.000000 -1789 0 10.000000 -1790 0 10.000000 -1791 0 10.000000 -1792 0 10.000000 -1793 0 10.000000 -1794 0 10.000000 -1795 0 10.000000 -1796 0 10.000000 -1797 0 10.000000 -1798 0 10.000000 -1799 0 10.000000 -1800 0 10.000000 -1801 0 10.000000 -1802 0 10.000000 -1803 0 10.000000 -1804 0 10.000000 -1805 0 10.000000 -1806 0 10.000000 -1807 0 10.000000 -1808 0 10.000000 -1809 0 10.000000 -1810 0 10.000000 -1811 0 10.000000 -1812 0 10.000000 -1813 0 10.000000 -1814 0 10.000000 -1815 0 10.000000 -1816 0 10.000000 -1817 0 10.000000 -1818 0 10.000000 -1819 0 10.000000 -1820 0 10.000000 -1821 0 10.000000 -1822 0 10.000000 -1823 0 10.000000 -1824 0 10.000000 -1825 0 10.000000 -1826 0 10.000000 -1827 0 10.000000 -1828 0 10.000000 -1829 0 10.000000 -1830 0 10.000000 -1831 0 10.000000 -1832 0 10.000000 -1833 0 10.000000 -1834 0 10.000000 -1835 0 10.000000 -1836 0 10.000000 -1837 0 10.000000 -1838 0 10.000000 -1839 0 10.000000 -1840 0 10.000000 -1841 0 10.000000 -1842 0 10.000000 -1843 0 10.000000 -1844 0 10.000000 -1845 0 10.000000 -1846 0 10.000000 -1847 0 10.000000 -1848 0 10.000000 -1849 0 10.000000 -1850 0 10.000000 -1851 0 10.000000 -1852 0 10.000000 -1853 0 10.000000 -1854 0 10.000000 -1855 0 10.000000 -1856 0 10.000000 -1857 0 10.000000 -1858 0 10.000000 -1859 0 10.000000 -1860 0 10.000000 -1861 0 10.000000 -1862 0 10.000000 -1863 0 10.000000 -1864 0 10.000000 -1865 0 10.000000 -1866 0 10.000000 -1867 0 10.000000 -1868 0 10.000000 -1869 0 10.000000 -1870 0 10.000000 -1871 0 10.000000 -1872 0 10.000000 -1873 0 10.000000 -1874 0 10.000000 -1875 0 10.000000 -1876 0 10.000000 -1877 0 10.000000 -1878 0 10.000000 -1879 0 10.000000 -1880 0 10.000000 -1881 0 10.000000 -1882 0 10.000000 -1883 0 10.000000 -1884 0 10.000000 -1885 0 10.000000 -1886 0 10.000000 -1887 0 10.000000 -1888 0 10.000000 -1889 0 10.000000 -1890 0 10.000000 -1891 0 10.000000 -1892 0 10.000000 -1893 0 10.000000 -1894 0 10.000000 -1895 0 10.000000 -1896 0 10.000000 -1897 0 10.000000 -1898 0 10.000000 -1899 0 10.000000 -1900 0 10.000000 -1901 0 10.000000 -1902 0 10.000000 -1903 0 10.000000 -1904 0 10.000000 -1905 0 10.000000 -1906 0 10.000000 -1907 0 10.000000 -1908 0 10.000000 -1909 0 10.000000 -1910 0 10.000000 -1911 0 10.000000 -1912 0 10.000000 -1913 0 10.000000 -1914 0 10.000000 -1915 0 10.000000 -1916 0 10.000000 -1917 0 10.000000 -1918 0 10.000000 -1919 0 10.000000 -1920 0 10.000000 -1921 0 10.000000 -1922 0 10.000000 -1923 0 10.000000 -1924 0 10.000000 -1925 0 10.000000 -1926 0 10.000000 -1927 0 10.000000 -1928 0 10.000000 -1929 0 10.000000 -1930 0 10.000000 -1931 0 10.000000 -1932 0 10.000000 -1933 0 10.000000 -1934 0 10.000000 -1935 0 10.000000 -1936 0 10.000000 -1937 0 10.000000 -1938 0 10.000000 -1939 0 10.000000 -1940 0 10.000000 -1941 0 10.000000 -1942 0 10.000000 -1943 0 10.000000 -1944 0 10.000000 -1945 0 10.000000 -1946 0 10.000000 -1947 0 10.000000 -1948 0 10.000000 -1949 0 10.000000 -1950 0 10.000000 -1951 0 10.000000 -1952 0 10.000000 -1953 0 10.000000 -1954 0 10.000000 -1955 0 10.000000 -1956 0 10.000000 -1957 0 10.000000 -1958 0 10.000000 -1959 0 10.000000 -1960 0 10.000000 -1961 0 10.000000 -1962 0 10.000000 -1963 0 10.000000 -1964 0 10.000000 -1965 0 10.000000 -1966 0 10.000000 -1967 0 10.000000 -1968 0 10.000000 -1969 0 10.000000 -1970 0 10.000000 -1971 0 10.000000 -1972 0 10.000000 -1973 0 10.000000 -1974 0 10.000000 -1975 0 10.000000 -1976 0 10.000000 -1977 0 10.000000 -1978 0 10.000000 -1979 0 10.000000 -1980 0 10.000000 -1981 0 10.000000 -1982 0 10.000000 -1983 0 10.000000 -1984 0 10.000000 -1985 0 10.000000 -1986 0 10.000000 -1987 0 10.000000 -1988 0 10.000000 -1989 0 10.000000 -1990 0 10.000000 -1991 0 10.000000 -1992 0 10.000000 -1993 0 10.000000 -1994 0 10.000000 -1995 0 10.000000 -1996 0 10.000000 -1997 0 10.000000 -1998 0 10.000000 -1999 0 10.000000 -2000 0 10.000000 -2001 0 10.000000 -2002 0 10.000000 -2003 0 10.000000 -2004 0 10.000000 -2005 0 10.000000 -2006 0 10.000000 -2007 0 10.000000 -2008 0 10.000000 -2009 0 10.000000 -2010 0 10.000000 -2011 0 10.000000 -2012 0 10.000000 -2013 0 10.000000 -2014 0 10.000000 -2015 0 10.000000 -2016 0 10.000000 -2017 0 10.000000 -2018 0 10.000000 -2019 0 10.000000 -2020 0 10.000000 -2021 0 10.000000 -2022 0 10.000000 -2023 0 10.000000 -2024 0 10.000000 -2025 0 10.000000 -2026 0 10.000000 -2027 0 10.000000 -2028 0 10.000000 -2029 0 10.000000 -2030 0 10.000000 -2031 0 10.000000 -2032 0 10.000000 -2033 0 10.000000 -2034 0 10.000000 -2035 0 10.000000 -2036 0 10.000000 -2037 0 10.000000 -2038 0 10.000000 -2039 0 10.000000 -2040 0 10.000000 -2041 0 10.000000 -2042 0 10.000000 -2043 0 10.000000 -2044 0 10.000000 -2045 0 10.000000 -2046 0 10.000000 -2047 0 10.000000 -2048 0 10.000000 -2049 0 10.000000 -2050 0 10.000000 -2051 0 10.000000 -2052 0 10.000000 -2053 0 10.000000 -2054 0 10.000000 -2055 0 10.000000 -2056 0 10.000000 -2057 0 10.000000 -2058 0 10.000000 -2059 0 10.000000 -2060 0 10.000000 -2061 0 10.000000 -2062 0 10.000000 -2063 0 10.000000 -2064 0 10.000000 -2065 0 10.000000 -2066 0 10.000000 -2067 0 10.000000 -2068 0 10.000000 -2069 0 10.000000 -2070 0 10.000000 -2071 0 10.000000 -2072 0 10.000000 -2073 0 10.000000 -2074 0 10.000000 -2075 0 10.000000 -2076 0 10.000000 -2077 0 10.000000 -2078 0 10.000000 -2079 0 10.000000 -2080 0 10.000000 -2081 0 10.000000 -2082 0 10.000000 -2083 0 10.000000 -2084 0 10.000000 -2085 0 10.000000 -2086 0 10.000000 -2087 0 10.000000 -2088 0 10.000000 -2089 0 10.000000 -2090 0 10.000000 -2091 0 10.000000 -2092 0 10.000000 -2093 0 10.000000 -2094 0 10.000000 -2095 0 10.000000 -2096 0 10.000000 -2097 0 10.000000 -2098 0 10.000000 -2099 0 10.000000 -2100 0 10.000000 -2101 0 10.000000 -2102 0 10.000000 -2103 0 10.000000 -2104 0 10.000000 -2105 0 10.000000 -2106 0 10.000000 -2107 0 10.000000 -2108 0 10.000000 -2109 0 10.000000 -2110 0 10.000000 -2111 0 10.000000 -2112 0 10.000000 -2113 0 10.000000 -2114 0 10.000000 -2115 0 10.000000 -2116 0 10.000000 -2117 0 10.000000 -2118 0 10.000000 -2119 0 10.000000 -2120 0 10.000000 -2121 0 10.000000 -2122 0 10.000000 -2123 0 10.000000 -2124 0 10.000000 -2125 0 10.000000 -2126 0 10.000000 -2127 0 10.000000 -2128 0 10.000000 -2129 0 10.000000 -2130 0 10.000000 -2131 0 10.000000 -2132 0 10.000000 -2133 0 10.000000 -2134 0 10.000000 -2135 0 10.000000 -2136 0 10.000000 -2137 0 10.000000 -2138 0 10.000000 -2139 0 10.000000 -2140 0 10.000000 -2141 0 10.000000 -2142 0 10.000000 -2143 0 10.000000 -2144 0 10.000000 -2145 0 10.000000 -2146 0 10.000000 -2147 0 10.000000 -2148 0 10.000000 -2149 0 10.000000 -2150 0 10.000000 -2151 0 10.000000 -2152 0 10.000000 -2153 0 10.000000 -2154 0 10.000000 -2155 0 10.000000 -2156 0 10.000000 -2157 0 10.000000 -2158 0 10.000000 -2159 0 10.000000 -2160 0 10.000000 -2161 0 10.000000 -2162 0 10.000000 -2163 0 10.000000 -2164 0 10.000000 -2165 0 10.000000 -2166 0 10.000000 -2167 0 10.000000 -2168 0 10.000000 -2169 0 10.000000 -2170 0 10.000000 -2171 0 10.000000 -2172 0 10.000000 -2173 0 10.000000 -2174 0 10.000000 -2175 0 10.000000 -2176 0 10.000000 -2177 0 10.000000 -2178 0 10.000000 -2179 0 10.000000 -2180 0 10.000000 -2181 0 10.000000 -2182 0 10.000000 -2183 0 10.000000 -2184 0 10.000000 -2185 0 10.000000 -2186 0 10.000000 -2187 0 10.000000 -2188 0 10.000000 -2189 0 10.000000 -2190 0 10.000000 -2191 0 10.000000 -2192 0 10.000000 -2193 0 10.000000 -2194 0 10.000000 -2195 0 10.000000 -2196 0 10.000000 -2197 0 10.000000 -2198 0 10.000000 -2199 0 10.000000 -2200 0 10.000000 -2201 0 10.000000 -2202 0 10.000000 -2203 0 10.000000 -2204 0 10.000000 -2205 0 10.000000 -2206 0 10.000000 -2207 0 10.000000 -2208 0 10.000000 -2209 0 10.000000 -2210 0 10.000000 -2211 0 10.000000 -2212 0 10.000000 -2213 0 10.000000 -2214 0 10.000000 -2215 0 10.000000 -2216 0 10.000000 -2217 0 10.000000 -2218 0 10.000000 -2219 0 10.000000 -2220 0 10.000000 -2221 0 10.000000 -2222 0 10.000000 -2223 0 10.000000 -2224 0 10.000000 -2225 0 10.000000 -2226 0 10.000000 -2227 0 10.000000 -2228 0 10.000000 -2229 0 10.000000 -2230 0 10.000000 -2231 0 10.000000 -2232 0 10.000000 -2233 0 10.000000 -2234 0 10.000000 -2235 0 10.000000 -2236 0 10.000000 -2237 0 10.000000 -2238 0 10.000000 -2239 0 10.000000 -2240 0 10.000000 -2241 0 10.000000 -2242 0 10.000000 -2243 0 10.000000 -2244 0 10.000000 -2245 0 10.000000 -2246 0 10.000000 -2247 0 10.000000 -2248 0 10.000000 -2249 0 10.000000 -2250 0 10.000000 -2251 0 10.000000 -2252 0 10.000000 -2253 0 10.000000 -2254 0 10.000000 -2255 0 10.000000 -2256 0 10.000000 -2257 0 10.000000 -2258 0 10.000000 -2259 0 10.000000 -2260 0 10.000000 -2261 0 10.000000 -2262 0 10.000000 -2263 0 10.000000 -2264 0 10.000000 -2265 0 10.000000 -2266 0 10.000000 -2267 0 10.000000 -2268 0 10.000000 -2269 0 10.000000 -2270 0 10.000000 -2271 0 10.000000 -2272 0 10.000000 -2273 0 10.000000 -2274 0 10.000000 -2275 0 10.000000 -2276 0 10.000000 -2277 0 10.000000 -2278 0 10.000000 -2279 0 10.000000 -2280 0 10.000000 -2281 0 10.000000 -2282 0 10.000000 -2283 0 10.000000 -2284 0 10.000000 -2285 0 10.000000 -2286 0 10.000000 -2287 0 10.000000 -2288 0 10.000000 -2289 0 10.000000 -2290 0 10.000000 -2291 0 10.000000 -2292 0 10.000000 -2293 0 10.000000 -2294 0 10.000000 -2295 0 10.000000 -2296 0 10.000000 -2297 0 10.000000 -2298 0 10.000000 -2299 0 10.000000 -2300 0 10.000000 -2301 0 10.000000 -2302 0 10.000000 -2303 0 10.000000 -2304 0 10.000000 -2305 0 10.000000 -2306 0 10.000000 -2307 0 10.000000 -2308 0 10.000000 -2309 0 10.000000 -2310 0 10.000000 -2311 0 10.000000 -2312 0 10.000000 -2313 0 10.000000 -2314 0 10.000000 -2315 0 10.000000 -2316 0 10.000000 -2317 0 10.000000 -2318 0 10.000000 -2319 0 10.000000 -2320 0 10.000000 -2321 0 10.000000 -2322 0 10.000000 -2323 0 10.000000 -2324 0 10.000000 -2325 0 10.000000 -2326 0 10.000000 -2327 0 10.000000 -2328 0 10.000000 -2329 0 10.000000 -2330 0 10.000000 -2331 0 10.000000 -2332 0 10.000000 -2333 0 10.000000 -2334 0 10.000000 -2335 0 10.000000 -2336 0 10.000000 -2337 0 10.000000 -2338 0 10.000000 -2339 0 10.000000 -2340 0 10.000000 -2341 0 10.000000 -2342 0 10.000000 -2343 0 10.000000 -2344 0 10.000000 -2345 0 10.000000 -2346 0 10.000000 -2347 0 10.000000 -2348 0 10.000000 -2349 0 10.000000 -2350 0 10.000000 -2351 0 10.000000 -2352 0 10.000000 -2353 0 10.000000 -2354 0 10.000000 -2355 0 10.000000 -2356 0 10.000000 -2357 0 10.000000 -2358 0 10.000000 -2359 0 10.000000 -2360 0 10.000000 -2361 0 10.000000 -2362 0 10.000000 -2363 0 10.000000 -2364 0 10.000000 -2365 0 10.000000 -2366 0 10.000000 -2367 0 10.000000 -2368 0 10.000000 -2369 0 10.000000 -2370 0 10.000000 -2371 0 10.000000 -2372 0 10.000000 -2373 0 10.000000 -2374 0 10.000000 -2375 0 10.000000 -2376 0 10.000000 -2377 0 10.000000 -2378 0 10.000000 -2379 0 10.000000 -2380 0 10.000000 -2381 0 10.000000 -2382 0 10.000000 -2383 0 10.000000 -2384 0 10.000000 -2385 0 10.000000 -2386 0 10.000000 -2387 0 10.000000 -2388 0 10.000000 -2389 0 10.000000 -2390 0 10.000000 -2391 0 10.000000 -2392 0 10.000000 -2393 0 10.000000 -2394 0 10.000000 -2395 0 10.000000 -2396 0 10.000000 -2397 0 10.000000 -2398 0 10.000000 -2399 0 10.000000 -2400 0 10.000000 -2401 0 10.000000 -2402 0 10.000000 -2403 0 10.000000 -2404 0 10.000000 -2405 0 10.000000 -2406 0 10.000000 -2407 0 10.000000 -2408 0 10.000000 -2409 0 10.000000 -2410 0 10.000000 -2411 0 10.000000 -2412 0 10.000000 -2413 0 10.000000 -2414 0 10.000000 -2415 0 10.000000 -2416 0 10.000000 -2417 0 10.000000 -2418 0 10.000000 -2419 0 10.000000 -2420 0 10.000000 -2421 0 10.000000 -2422 0 10.000000 -2423 0 10.000000 -2424 0 10.000000 -2425 0 10.000000 -2426 0 10.000000 -2427 0 10.000000 -2428 0 10.000000 -2429 0 10.000000 -2430 0 10.000000 -2431 0 10.000000 -2432 0 10.000000 -2433 0 10.000000 -2434 0 10.000000 -2435 0 10.000000 -2436 0 10.000000 -2437 0 10.000000 -2438 0 10.000000 -2439 0 10.000000 -2440 0 10.000000 -2441 0 10.000000 -2442 0 10.000000 -2443 0 10.000000 -2444 0 10.000000 -2445 0 10.000000 -2446 0 10.000000 -2447 0 10.000000 -2448 0 10.000000 -2449 0 10.000000 -2450 0 10.000000 -2451 0 10.000000 -2452 0 10.000000 -2453 0 10.000000 -2454 0 10.000000 -2455 0 10.000000 -2456 0 10.000000 -2457 0 10.000000 -2458 0 10.000000 -2459 0 10.000000 -2460 0 10.000000 -2461 0 10.000000 -2462 0 10.000000 -2463 0 10.000000 -2464 0 10.000000 -2465 0 10.000000 -2466 0 10.000000 -2467 0 10.000000 -2468 0 10.000000 -2469 0 10.000000 -2470 0 10.000000 -2471 0 10.000000 -2472 0 10.000000 -2473 0 10.000000 -2474 0 10.000000 -2475 0 10.000000 -2476 0 10.000000 -2477 0 10.000000 -2478 0 10.000000 -2479 0 10.000000 -2480 0 10.000000 -2481 0 10.000000 -2482 0 10.000000 -2483 0 10.000000 -2484 0 10.000000 -2485 0 10.000000 -2486 0 10.000000 -2487 0 10.000000 -2488 0 10.000000 -2489 0 10.000000 -2490 0 10.000000 -2491 0 10.000000 -2492 0 10.000000 -2493 0 10.000000 -2494 0 10.000000 -2495 0 10.000000 -2496 0 10.000000 -2497 0 10.000000 -2498 0 10.000000 -2499 0 10.000000 -2500 0 10.000000 -2501 0 10.000000 -2502 0 10.000000 -2503 0 10.000000 -2504 0 10.000000 -2505 0 10.000000 -2506 0 10.000000 -2507 0 10.000000 -2508 0 10.000000 -2509 0 10.000000 -2510 0 10.000000 -2511 0 10.000000 -2512 0 10.000000 -2513 0 10.000000 -2514 0 10.000000 -2515 0 10.000000 -2516 0 10.000000 -2517 0 10.000000 -2518 0 10.000000 -2519 0 10.000000 -2520 0 10.000000 -2521 0 10.000000 -2522 0 10.000000 -2523 0 10.000000 -2524 0 10.000000 -2525 0 10.000000 -2526 0 10.000000 -2527 0 10.000000 -2528 0 10.000000 -2529 0 10.000000 -2530 0 10.000000 -2531 0 10.000000 -2532 0 10.000000 -2533 0 10.000000 -2534 0 10.000000 -2535 0 10.000000 -2536 0 10.000000 -2537 0 10.000000 -2538 0 10.000000 -2539 0 10.000000 -2540 0 10.000000 -2541 0 10.000000 -2542 0 10.000000 -2543 0 10.000000 -2544 0 10.000000 -2545 0 10.000000 -2546 0 10.000000 -2547 0 10.000000 -2548 0 10.000000 -2549 0 10.000000 -2550 0 10.000000 -2551 0 10.000000 -2552 0 10.000000 -2553 0 10.000000 -2554 0 10.000000 -2555 0 10.000000 -2556 0 10.000000 -2557 0 10.000000 -2558 0 10.000000 -2559 0 10.000000 -2560 0 10.000000 -2561 0 10.000000 -2562 0 10.000000 -2563 0 10.000000 -2564 0 10.000000 -2565 0 10.000000 -2566 0 10.000000 -2567 0 10.000000 -2568 0 10.000000 -2569 0 10.000000 -2570 0 10.000000 -2571 0 10.000000 -2572 0 10.000000 -2573 0 10.000000 -2574 0 10.000000 -2575 0 10.000000 -2576 0 10.000000 -2577 0 10.000000 -2578 0 10.000000 -2579 0 10.000000 -2580 0 10.000000 -2581 0 10.000000 -2582 0 10.000000 -2583 0 10.000000 -2584 0 10.000000 -2585 0 10.000000 -2586 0 10.000000 -2587 0 10.000000 -2588 0 10.000000 -2589 0 10.000000 -2590 0 10.000000 -2591 0 10.000000 -2592 0 10.000000 -2593 0 10.000000 -2594 0 10.000000 -2595 0 10.000000 -2596 0 10.000000 -2597 0 10.000000 -2598 0 10.000000 -2599 0 10.000000 -2600 0 10.000000 -2601 0 10.000000 -2602 0 10.000000 -2603 0 10.000000 -2604 0 10.000000 -2605 0 10.000000 -2606 0 10.000000 -2607 0 10.000000 -2608 0 10.000000 -2609 0 10.000000 -2610 0 10.000000 -2611 0 10.000000 -2612 0 10.000000 -2613 0 10.000000 -2614 0 10.000000 -2615 0 10.000000 -2616 0 10.000000 -2617 0 10.000000 -2618 0 10.000000 -2619 0 10.000000 -2620 0 10.000000 -2621 0 10.000000 -2622 0 10.000000 -2623 0 10.000000 -2624 0 10.000000 -2625 0 10.000000 -2626 0 10.000000 -2627 0 10.000000 -2628 0 10.000000 -2629 0 10.000000 -2630 0 10.000000 -2631 0 10.000000 -2632 0 10.000000 -2633 0 10.000000 -2634 0 10.000000 -2635 0 10.000000 -2636 0 10.000000 -2637 0 10.000000 -2638 0 10.000000 -2639 0 10.000000 -2640 0 10.000000 -2641 0 10.000000 -2642 0 10.000000 -2643 0 10.000000 -2644 0 10.000000 -2645 0 10.000000 -2646 0 10.000000 -2647 0 10.000000 -2648 0 10.000000 -2649 0 10.000000 -2650 0 10.000000 -2651 0 10.000000 -2652 0 10.000000 -2653 0 10.000000 -2654 0 10.000000 -2655 0 10.000000 -2656 0 10.000000 -2657 0 10.000000 -2658 0 10.000000 -2659 0 10.000000 -2660 0 10.000000 -2661 0 10.000000 -2662 0 10.000000 -2663 0 10.000000 -2664 0 10.000000 -2665 0 10.000000 -2666 0 10.000000 -2667 0 10.000000 -2668 0 10.000000 -2669 0 10.000000 -2670 0 10.000000 -2671 0 10.000000 -2672 0 10.000000 -2673 0 10.000000 -2674 0 10.000000 -2675 0 10.000000 -2676 0 10.000000 -2677 0 10.000000 -2678 0 10.000000 -2679 0 10.000000 -2680 0 10.000000 -2681 0 10.000000 -2682 0 10.000000 -2683 0 10.000000 -2684 0 10.000000 -2685 0 10.000000 -2686 0 10.000000 -2687 0 10.000000 -2688 0 10.000000 -2689 0 10.000000 -2690 0 10.000000 -2691 0 10.000000 -2692 0 10.000000 -2693 0 10.000000 -2694 0 10.000000 -2695 0 10.000000 -2696 0 10.000000 -2697 0 10.000000 -2698 0 10.000000 -2699 0 10.000000 -2700 0 10.000000 -2701 0 10.000000 -2702 0 10.000000 -2703 0 10.000000 -2704 0 10.000000 -2705 0 10.000000 -2706 0 10.000000 -2707 0 10.000000 -2708 0 10.000000 -2709 0 10.000000 -2710 0 10.000000 -2711 0 10.000000 -2712 0 10.000000 -2713 0 10.000000 -2714 0 10.000000 -2715 0 10.000000 -2716 0 10.000000 -2717 0 10.000000 -2718 0 10.000000 -2719 0 10.000000 -2720 0 10.000000 -2721 0 10.000000 -2722 0 10.000000 -2723 0 10.000000 -2724 0 10.000000 -2725 0 10.000000 -2726 0 10.000000 -2727 0 10.000000 -2728 0 10.000000 -2729 0 10.000000 -2730 0 10.000000 -2731 0 10.000000 -2732 0 10.000000 -2733 0 10.000000 -2734 0 10.000000 -2735 0 10.000000 -2736 0 10.000000 -2737 0 10.000000 -2738 0 10.000000 -2739 0 10.000000 -2740 0 10.000000 -2741 0 10.000000 -2742 0 10.000000 -2743 0 10.000000 -2744 0 10.000000 -2745 0 10.000000 -2746 0 10.000000 -2747 0 10.000000 -2748 0 10.000000 -2749 0 10.000000 -2750 0 10.000000 -2751 0 10.000000 -2752 0 10.000000 -2753 0 10.000000 -2754 0 10.000000 -2755 0 10.000000 -2756 0 10.000000 -2757 0 10.000000 -2758 0 10.000000 -2759 0 10.000000 -2760 0 10.000000 -2761 0 10.000000 -2762 0 10.000000 -2763 0 10.000000 -2764 0 10.000000 -2765 0 10.000000 -2766 0 10.000000 -2767 0 10.000000 -2768 0 10.000000 -2769 0 10.000000 -2770 0 10.000000 -2771 0 10.000000 -2772 0 10.000000 -2773 0 10.000000 -2774 0 10.000000 -2775 0 10.000000 -2776 0 10.000000 -2777 0 10.000000 -2778 0 10.000000 -2779 0 10.000000 -2780 0 10.000000 -2781 0 10.000000 -2782 0 10.000000 -2783 0 10.000000 -2784 0 10.000000 -2785 0 10.000000 -2786 0 10.000000 -2787 0 10.000000 -2788 0 10.000000 -2789 0 10.000000 -2790 0 10.000000 -2791 0 10.000000 -2792 0 10.000000 -2793 0 10.000000 -2794 0 10.000000 -2795 0 10.000000 -2796 0 10.000000 -2797 0 10.000000 -2798 0 10.000000 -2799 0 10.000000 -2800 0 10.000000 -2801 0 10.000000 -2802 0 10.000000 -2803 0 10.000000 -2804 0 10.000000 -2805 0 10.000000 -2806 0 10.000000 -2807 0 10.000000 -2808 0 10.000000 -2809 0 10.000000 -2810 0 10.000000 -2811 0 10.000000 -2812 0 10.000000 -2813 0 10.000000 -2814 0 10.000000 -2815 0 10.000000 -2816 0 10.000000 -2817 0 10.000000 -2818 0 10.000000 -2819 0 10.000000 -2820 0 10.000000 -2821 0 10.000000 -2822 0 10.000000 -2823 0 10.000000 -2824 0 10.000000 -2825 0 10.000000 -2826 0 10.000000 -2827 0 10.000000 -2828 0 10.000000 -2829 0 10.000000 -2830 0 10.000000 -2831 0 10.000000 -2832 0 10.000000 -2833 0 10.000000 -2834 0 10.000000 -2835 0 10.000000 -2836 0 10.000000 -End NodalData - -Begin NodalData DENSITY -1 0 1.000000 -2 0 1.000000 -3 0 1.000000 -4 0 1.000000 -5 0 1.000000 -6 0 1.000000 -7 0 1.000000 -8 0 1.000000 -9 0 1.000000 -10 0 1.000000 -11 0 1.000000 -12 0 1.000000 -13 0 1.000000 -14 0 1.000000 -15 0 1.000000 -16 0 1.000000 -17 0 1.000000 -18 0 1.000000 -19 0 1.000000 -20 0 1.000000 -21 0 1.000000 -22 0 1.000000 -23 0 1.000000 -24 0 1.000000 -25 0 1.000000 -26 0 1.000000 -27 0 1.000000 -28 0 1.000000 -29 0 1.000000 -30 0 1.000000 -31 0 1.000000 -32 0 1.000000 -33 0 1.000000 -34 0 1.000000 -35 0 1.000000 -36 0 1.000000 -37 0 1.000000 -38 0 1.000000 -39 0 1.000000 -40 0 1.000000 -41 0 1.000000 -42 0 1.000000 -43 0 1.000000 -44 0 1.000000 -45 0 1.000000 -46 0 1.000000 -47 0 1.000000 -48 0 1.000000 -49 0 1.000000 -50 0 1.000000 -51 0 1.000000 -52 0 1.000000 -53 0 1.000000 -54 0 1.000000 -55 0 1.000000 -56 0 1.000000 -57 0 1.000000 -58 0 1.000000 -59 0 1.000000 -60 0 1.000000 -61 0 1.000000 -62 0 1.000000 -63 0 1.000000 -64 0 1.000000 -65 0 1.000000 -66 0 1.000000 -67 0 1.000000 -68 0 1.000000 -69 0 1.000000 -70 0 1.000000 -71 0 1.000000 -72 0 1.000000 -73 0 1.000000 -74 0 1.000000 -75 0 1.000000 -76 0 1.000000 -77 0 1.000000 -78 0 1.000000 -79 0 1.000000 -80 0 1.000000 -81 0 1.000000 -82 0 1.000000 -83 0 1.000000 -84 0 1.000000 -85 0 1.000000 -86 0 1.000000 -87 0 1.000000 -88 0 1.000000 -89 0 1.000000 -90 0 1.000000 -91 0 1.000000 -92 0 1.000000 -93 0 1.000000 -94 0 1.000000 -95 0 1.000000 -96 0 1.000000 -97 0 1.000000 -98 0 1.000000 -99 0 1.000000 -100 0 1.000000 -101 0 1.000000 -102 0 1.000000 -103 0 1.000000 -104 0 1.000000 -105 0 1.000000 -106 0 1.000000 -107 0 1.000000 -108 0 1.000000 -109 0 1.000000 -110 0 1.000000 -111 0 1.000000 -112 0 1.000000 -113 0 1.000000 -114 0 1.000000 -115 0 1.000000 -116 0 1.000000 -117 0 1.000000 -118 0 1.000000 -119 0 1.000000 -120 0 1.000000 -121 0 1.000000 -122 0 1.000000 -123 0 1.000000 -124 0 1.000000 -125 0 1.000000 -126 0 1.000000 -127 0 1.000000 -128 0 1.000000 -129 0 1.000000 -130 0 1.000000 -131 0 1.000000 -132 0 1.000000 -133 0 1.000000 -134 0 1.000000 -135 0 1.000000 -136 0 1.000000 -137 0 1.000000 -138 0 1.000000 -139 0 1.000000 -140 0 1.000000 -141 0 1.000000 -142 0 1.000000 -143 0 1.000000 -144 0 1.000000 -145 0 1.000000 -146 0 1.000000 -147 0 1.000000 -148 0 1.000000 -149 0 1.000000 -150 0 1.000000 -151 0 1.000000 -152 0 1.000000 -153 0 1.000000 -154 0 1.000000 -155 0 1.000000 -156 0 1.000000 -157 0 1.000000 -158 0 1.000000 -159 0 1.000000 -160 0 1.000000 -161 0 1.000000 -162 0 1.000000 -163 0 1.000000 -164 0 1.000000 -165 0 1.000000 -166 0 1.000000 -167 0 1.000000 -168 0 1.000000 -169 0 1.000000 -170 0 1.000000 -171 0 1.000000 -172 0 1.000000 -173 0 1.000000 -174 0 1.000000 -175 0 1.000000 -176 0 1.000000 -177 0 1.000000 -178 0 1.000000 -179 0 1.000000 -180 0 1.000000 -181 0 1.000000 -182 0 1.000000 -183 0 1.000000 -184 0 1.000000 -185 0 1.000000 -186 0 1.000000 -187 0 1.000000 -188 0 1.000000 -189 0 1.000000 -190 0 1.000000 -191 0 1.000000 -192 0 1.000000 -193 0 1.000000 -194 0 1.000000 -195 0 1.000000 -196 0 1.000000 -197 0 1.000000 -198 0 1.000000 -199 0 1.000000 -200 0 1.000000 -201 0 1.000000 -202 0 1.000000 -203 0 1.000000 -204 0 1.000000 -205 0 1.000000 -206 0 1.000000 -207 0 1.000000 -208 0 1.000000 -209 0 1.000000 -210 0 1.000000 -211 0 1.000000 -212 0 1.000000 -213 0 1.000000 -214 0 1.000000 -215 0 1.000000 -216 0 1.000000 -217 0 1.000000 -218 0 1.000000 -219 0 1.000000 -220 0 1.000000 -221 0 1.000000 -222 0 1.000000 -223 0 1.000000 -224 0 1.000000 -225 0 1.000000 -226 0 1.000000 -227 0 1.000000 -228 0 1.000000 -229 0 1.000000 -230 0 1.000000 -231 0 1.000000 -232 0 1.000000 -233 0 1.000000 -234 0 1.000000 -235 0 1.000000 -236 0 1.000000 -237 0 1.000000 -238 0 1.000000 -239 0 1.000000 -240 0 1.000000 -241 0 1.000000 -242 0 1.000000 -243 0 1.000000 -244 0 1.000000 -245 0 1.000000 -246 0 1.000000 -247 0 1.000000 -248 0 1.000000 -249 0 1.000000 -250 0 1.000000 -251 0 1.000000 -252 0 1.000000 -253 0 1.000000 -254 0 1.000000 -255 0 1.000000 -256 0 1.000000 -257 0 1.000000 -258 0 1.000000 -259 0 1.000000 -260 0 1.000000 -261 0 1.000000 -262 0 1.000000 -263 0 1.000000 -264 0 1.000000 -265 0 1.000000 -266 0 1.000000 -267 0 1.000000 -268 0 1.000000 -269 0 1.000000 -270 0 1.000000 -271 0 1.000000 -272 0 1.000000 -273 0 1.000000 -274 0 1.000000 -275 0 1.000000 -276 0 1.000000 -277 0 1.000000 -278 0 1.000000 -279 0 1.000000 -280 0 1.000000 -281 0 1.000000 -282 0 1.000000 -283 0 1.000000 -284 0 1.000000 -285 0 1.000000 -286 0 1.000000 -287 0 1.000000 -288 0 1.000000 -289 0 1.000000 -290 0 1.000000 -291 0 1.000000 -292 0 1.000000 -293 0 1.000000 -294 0 1.000000 -295 0 1.000000 -296 0 1.000000 -297 0 1.000000 -298 0 1.000000 -299 0 1.000000 -300 0 1.000000 -301 0 1.000000 -302 0 1.000000 -303 0 1.000000 -304 0 1.000000 -305 0 1.000000 -306 0 1.000000 -307 0 1.000000 -308 0 1.000000 -309 0 1.000000 -310 0 1.000000 -311 0 1.000000 -312 0 1.000000 -313 0 1.000000 -314 0 1.000000 -315 0 1.000000 -316 0 1.000000 -317 0 1.000000 -318 0 1.000000 -319 0 1.000000 -320 0 1.000000 -321 0 1.000000 -322 0 1.000000 -323 0 1.000000 -324 0 1.000000 -325 0 1.000000 -326 0 1.000000 -327 0 1.000000 -328 0 1.000000 -329 0 1.000000 -330 0 1.000000 -331 0 1.000000 -332 0 1.000000 -333 0 1.000000 -334 0 1.000000 -335 0 1.000000 -336 0 1.000000 -337 0 1.000000 -338 0 1.000000 -339 0 1.000000 -340 0 1.000000 -341 0 1.000000 -342 0 1.000000 -343 0 1.000000 -344 0 1.000000 -345 0 1.000000 -346 0 1.000000 -347 0 1.000000 -348 0 1.000000 -349 0 1.000000 -350 0 1.000000 -351 0 1.000000 -352 0 1.000000 -353 0 1.000000 -354 0 1.000000 -355 0 1.000000 -356 0 1.000000 -357 0 1.000000 -358 0 1.000000 -359 0 1.000000 -360 0 1.000000 -361 0 1.000000 -362 0 1.000000 -363 0 1.000000 -364 0 1.000000 -365 0 1.000000 -366 0 1.000000 -367 0 1.000000 -368 0 1.000000 -369 0 1.000000 -370 0 1.000000 -371 0 1.000000 -372 0 1.000000 -373 0 1.000000 -374 0 1.000000 -375 0 1.000000 -376 0 1.000000 -377 0 1.000000 -378 0 1.000000 -379 0 1.000000 -380 0 1.000000 -381 0 1.000000 -382 0 1.000000 -383 0 1.000000 -384 0 1.000000 -385 0 1.000000 -386 0 1.000000 -387 0 1.000000 -388 0 1.000000 -389 0 1.000000 -390 0 1.000000 -391 0 1.000000 -392 0 1.000000 -393 0 1.000000 -394 0 1.000000 -395 0 1.000000 -396 0 1.000000 -397 0 1.000000 -398 0 1.000000 -399 0 1.000000 -400 0 1.000000 -401 0 1.000000 -402 0 1.000000 -403 0 1.000000 -404 0 1.000000 -405 0 1.000000 -406 0 1.000000 -407 0 1.000000 -408 0 1.000000 -409 0 1.000000 -410 0 1.000000 -411 0 1.000000 -412 0 1.000000 -413 0 1.000000 -414 0 1.000000 -415 0 1.000000 -416 0 1.000000 -417 0 1.000000 -418 0 1.000000 -419 0 1.000000 -420 0 1.000000 -421 0 1.000000 -422 0 1.000000 -423 0 1.000000 -424 0 1.000000 -425 0 1.000000 -426 0 1.000000 -427 0 1.000000 -428 0 1.000000 -429 0 1.000000 -430 0 1.000000 -431 0 1.000000 -432 0 1.000000 -433 0 1.000000 -434 0 1.000000 -435 0 1.000000 -436 0 1.000000 -437 0 1.000000 -438 0 1.000000 -439 0 1.000000 -440 0 1.000000 -441 0 1.000000 -442 0 1.000000 -443 0 1.000000 -444 0 1.000000 -445 0 1.000000 -446 0 1.000000 -447 0 1.000000 -448 0 1.000000 -449 0 1.000000 -450 0 1.000000 -451 0 1.000000 -452 0 1.000000 -453 0 1.000000 -454 0 1.000000 -455 0 1.000000 -456 0 1.000000 -457 0 1.000000 -458 0 1.000000 -459 0 1.000000 -460 0 1.000000 -461 0 1.000000 -462 0 1.000000 -463 0 1.000000 -464 0 1.000000 -465 0 1.000000 -466 0 1.000000 -467 0 1.000000 -468 0 1.000000 -469 0 1.000000 -470 0 1.000000 -471 0 1.000000 -472 0 1.000000 -473 0 1.000000 -474 0 1.000000 -475 0 1.000000 -476 0 1.000000 -477 0 1.000000 -478 0 1.000000 -479 0 1.000000 -480 0 1.000000 -481 0 1.000000 -482 0 1.000000 -483 0 1.000000 -484 0 1.000000 -485 0 1.000000 -486 0 1.000000 -487 0 1.000000 -488 0 1.000000 -489 0 1.000000 -490 0 1.000000 -491 0 1.000000 -492 0 1.000000 -493 0 1.000000 -494 0 1.000000 -495 0 1.000000 -496 0 1.000000 -497 0 1.000000 -498 0 1.000000 -499 0 1.000000 -500 0 1.000000 -501 0 1.000000 -502 0 1.000000 -503 0 1.000000 -504 0 1.000000 -505 0 1.000000 -506 0 1.000000 -507 0 1.000000 -508 0 1.000000 -509 0 1.000000 -510 0 1.000000 -511 0 1.000000 -512 0 1.000000 -513 0 1.000000 -514 0 1.000000 -515 0 1.000000 -516 0 1.000000 -517 0 1.000000 -518 0 1.000000 -519 0 1.000000 -520 0 1.000000 -521 0 1.000000 -522 0 1.000000 -523 0 1.000000 -524 0 1.000000 -525 0 1.000000 -526 0 1.000000 -527 0 1.000000 -528 0 1.000000 -529 0 1.000000 -530 0 1.000000 -531 0 1.000000 -532 0 1.000000 -533 0 1.000000 -534 0 1.000000 -535 0 1.000000 -536 0 1.000000 -537 0 1.000000 -538 0 1.000000 -539 0 1.000000 -540 0 1.000000 -541 0 1.000000 -542 0 1.000000 -543 0 1.000000 -544 0 1.000000 -545 0 1.000000 -546 0 1.000000 -547 0 1.000000 -548 0 1.000000 -549 0 1.000000 -550 0 1.000000 -551 0 1.000000 -552 0 1.000000 -553 0 1.000000 -554 0 1.000000 -555 0 1.000000 -556 0 1.000000 -557 0 1.000000 -558 0 1.000000 -559 0 1.000000 -560 0 1.000000 -561 0 1.000000 -562 0 1.000000 -563 0 1.000000 -564 0 1.000000 -565 0 1.000000 -566 0 1.000000 -567 0 1.000000 -568 0 1.000000 -569 0 1.000000 -570 0 1.000000 -571 0 1.000000 -572 0 1.000000 -573 0 1.000000 -574 0 1.000000 -575 0 1.000000 -576 0 1.000000 -577 0 1.000000 -578 0 1.000000 -579 0 1.000000 -580 0 1.000000 -581 0 1.000000 -582 0 1.000000 -583 0 1.000000 -584 0 1.000000 -585 0 1.000000 -586 0 1.000000 -587 0 1.000000 -588 0 1.000000 -589 0 1.000000 -590 0 1.000000 -591 0 1.000000 -592 0 1.000000 -593 0 1.000000 -594 0 1.000000 -595 0 1.000000 -596 0 1.000000 -597 0 1.000000 -598 0 1.000000 -599 0 1.000000 -600 0 1.000000 -601 0 1.000000 -602 0 1.000000 -603 0 1.000000 -604 0 1.000000 -605 0 1.000000 -606 0 1.000000 -607 0 1.000000 -608 0 1.000000 -609 0 1.000000 -610 0 1.000000 -611 0 1.000000 -612 0 1.000000 -613 0 1.000000 -614 0 1.000000 -615 0 1.000000 -616 0 1.000000 -617 0 1.000000 -618 0 1.000000 -619 0 1.000000 -620 0 1.000000 -621 0 1.000000 -622 0 1.000000 -623 0 1.000000 -624 0 1.000000 -625 0 1.000000 -626 0 1.000000 -627 0 1.000000 -628 0 1.000000 -629 0 1.000000 -630 0 1.000000 -631 0 1.000000 -632 0 1.000000 -633 0 1.000000 -634 0 1.000000 -635 0 1.000000 -636 0 1.000000 -637 0 1.000000 -638 0 1.000000 -639 0 1.000000 -640 0 1.000000 -641 0 1.000000 -642 0 1.000000 -643 0 1.000000 -644 0 1.000000 -645 0 1.000000 -646 0 1.000000 -647 0 1.000000 -648 0 1.000000 -649 0 1.000000 -650 0 1.000000 -651 0 1.000000 -652 0 1.000000 -653 0 1.000000 -654 0 1.000000 -655 0 1.000000 -656 0 1.000000 -657 0 1.000000 -658 0 1.000000 -659 0 1.000000 -660 0 1.000000 -661 0 1.000000 -662 0 1.000000 -663 0 1.000000 -664 0 1.000000 -665 0 1.000000 -666 0 1.000000 -667 0 1.000000 -668 0 1.000000 -669 0 1.000000 -670 0 1.000000 -671 0 1.000000 -672 0 1.000000 -673 0 1.000000 -674 0 1.000000 -675 0 1.000000 -676 0 1.000000 -677 0 1.000000 -678 0 1.000000 -679 0 1.000000 -680 0 1.000000 -681 0 1.000000 -682 0 1.000000 -683 0 1.000000 -684 0 1.000000 -685 0 1.000000 -686 0 1.000000 -687 0 1.000000 -688 0 1.000000 -689 0 1.000000 -690 0 1.000000 -691 0 1.000000 -692 0 1.000000 -693 0 1.000000 -694 0 1.000000 -695 0 1.000000 -696 0 1.000000 -697 0 1.000000 -698 0 1.000000 -699 0 1.000000 -700 0 1.000000 -701 0 1.000000 -702 0 1.000000 -703 0 1.000000 -704 0 1.000000 -705 0 1.000000 -706 0 1.000000 -707 0 1.000000 -708 0 1.000000 -709 0 1.000000 -710 0 1.000000 -711 0 1.000000 -712 0 1.000000 -713 0 1.000000 -714 0 1.000000 -715 0 1.000000 -716 0 1.000000 -717 0 1.000000 -718 0 1.000000 -719 0 1.000000 -720 0 1.000000 -721 0 1.000000 -722 0 1.000000 -723 0 1.000000 -724 0 1.000000 -725 0 1.000000 -726 0 1.000000 -727 0 1.000000 -728 0 1.000000 -729 0 1.000000 -730 0 1.000000 -731 0 1.000000 -732 0 1.000000 -733 0 1.000000 -734 0 1.000000 -735 0 1.000000 -736 0 1.000000 -737 0 1.000000 -738 0 1.000000 -739 0 1.000000 -740 0 1.000000 -741 0 1.000000 -742 0 1.000000 -743 0 1.000000 -744 0 1.000000 -745 0 1.000000 -746 0 1.000000 -747 0 1.000000 -748 0 1.000000 -749 0 1.000000 -750 0 1.000000 -751 0 1.000000 -752 0 1.000000 -753 0 1.000000 -754 0 1.000000 -755 0 1.000000 -756 0 1.000000 -757 0 1.000000 -758 0 1.000000 -759 0 1.000000 -760 0 1.000000 -761 0 1.000000 -762 0 1.000000 -763 0 1.000000 -764 0 1.000000 -765 0 1.000000 -766 0 1.000000 -767 0 1.000000 -768 0 1.000000 -769 0 1.000000 -770 0 1.000000 -771 0 1.000000 -772 0 1.000000 -773 0 1.000000 -774 0 1.000000 -775 0 1.000000 -776 0 1.000000 -777 0 1.000000 -778 0 1.000000 -779 0 1.000000 -780 0 1.000000 -781 0 1.000000 -782 0 1.000000 -783 0 1.000000 -784 0 1.000000 -785 0 1.000000 -786 0 1.000000 -787 0 1.000000 -788 0 1.000000 -789 0 1.000000 -790 0 1.000000 -791 0 1.000000 -792 0 1.000000 -793 0 1.000000 -794 0 1.000000 -795 0 1.000000 -796 0 1.000000 -797 0 1.000000 -798 0 1.000000 -799 0 1.000000 -800 0 1.000000 -801 0 1.000000 -802 0 1.000000 -803 0 1.000000 -804 0 1.000000 -805 0 1.000000 -806 0 1.000000 -807 0 1.000000 -808 0 1.000000 -809 0 1.000000 -810 0 1.000000 -811 0 1.000000 -812 0 1.000000 -813 0 1.000000 -814 0 1.000000 -815 0 1.000000 -816 0 1.000000 -817 0 1.000000 -818 0 1.000000 -819 0 1.000000 -820 0 1.000000 -821 0 1.000000 -822 0 1.000000 -823 0 1.000000 -824 0 1.000000 -825 0 1.000000 -826 0 1.000000 -827 0 1.000000 -828 0 1.000000 -829 0 1.000000 -830 0 1.000000 -831 0 1.000000 -832 0 1.000000 -833 0 1.000000 -834 0 1.000000 -835 0 1.000000 -836 0 1.000000 -837 0 1.000000 -838 0 1.000000 -839 0 1.000000 -840 0 1.000000 -841 0 1.000000 -842 0 1.000000 -843 0 1.000000 -844 0 1.000000 -845 0 1.000000 -846 0 1.000000 -847 0 1.000000 -848 0 1.000000 -849 0 1.000000 -850 0 1.000000 -851 0 1.000000 -852 0 1.000000 -853 0 1.000000 -854 0 1.000000 -855 0 1.000000 -856 0 1.000000 -857 0 1.000000 -858 0 1.000000 -859 0 1.000000 -860 0 1.000000 -861 0 1.000000 -862 0 1.000000 -863 0 1.000000 -864 0 1.000000 -865 0 1.000000 -866 0 1.000000 -867 0 1.000000 -868 0 1.000000 -869 0 1.000000 -870 0 1.000000 -871 0 1.000000 -872 0 1.000000 -873 0 1.000000 -874 0 1.000000 -875 0 1.000000 -876 0 1.000000 -877 0 1.000000 -878 0 1.000000 -879 0 1.000000 -880 0 1.000000 -881 0 1.000000 -882 0 1.000000 -883 0 1.000000 -884 0 1.000000 -885 0 1.000000 -886 0 1.000000 -887 0 1.000000 -888 0 1.000000 -889 0 1.000000 -890 0 1.000000 -891 0 1.000000 -892 0 1.000000 -893 0 1.000000 -894 0 1.000000 -895 0 1.000000 -896 0 1.000000 -897 0 1.000000 -898 0 1.000000 -899 0 1.000000 -900 0 1.000000 -901 0 1.000000 -902 0 1.000000 -903 0 1.000000 -904 0 1.000000 -905 0 1.000000 -906 0 1.000000 -907 0 1.000000 -908 0 1.000000 -909 0 1.000000 -910 0 1.000000 -911 0 1.000000 -912 0 1.000000 -913 0 1.000000 -914 0 1.000000 -915 0 1.000000 -916 0 1.000000 -917 0 1.000000 -918 0 1.000000 -919 0 1.000000 -920 0 1.000000 -921 0 1.000000 -922 0 1.000000 -923 0 1.000000 -924 0 1.000000 -925 0 1.000000 -926 0 1.000000 -927 0 1.000000 -928 0 1.000000 -929 0 1.000000 -930 0 1.000000 -931 0 1.000000 -932 0 1.000000 -933 0 1.000000 -934 0 1.000000 -935 0 1.000000 -936 0 1.000000 -937 0 1.000000 -938 0 1.000000 -939 0 1.000000 -940 0 1.000000 -941 0 1.000000 -942 0 1.000000 -943 0 1.000000 -944 0 1.000000 -945 0 1.000000 -946 0 1.000000 -947 0 1.000000 -948 0 1.000000 -949 0 1.000000 -950 0 1.000000 -951 0 1.000000 -952 0 1.000000 -953 0 1.000000 -954 0 1.000000 -955 0 1.000000 -956 0 1.000000 -957 0 1.000000 -958 0 1.000000 -959 0 1.000000 -960 0 1.000000 -961 0 1.000000 -962 0 1.000000 -963 0 1.000000 -964 0 1.000000 -965 0 1.000000 -966 0 1.000000 -967 0 1.000000 -968 0 1.000000 -969 0 1.000000 -970 0 1.000000 -971 0 1.000000 -972 0 1.000000 -973 0 1.000000 -974 0 1.000000 -975 0 1.000000 -976 0 1.000000 -977 0 1.000000 -978 0 1.000000 -979 0 1.000000 -980 0 1.000000 -981 0 1.000000 -982 0 1.000000 -983 0 1.000000 -984 0 1.000000 -985 0 1.000000 -986 0 1.000000 -987 0 1.000000 -988 0 1.000000 -989 0 1.000000 -990 0 1.000000 -991 0 1.000000 -992 0 1.000000 -993 0 1.000000 -994 0 1.000000 -995 0 1.000000 -996 0 1.000000 -997 0 1.000000 -998 0 1.000000 -999 0 1.000000 -1000 0 1.000000 -1001 0 1.000000 -1002 0 1.000000 -1003 0 1.000000 -1004 0 1.000000 -1005 0 1.000000 -1006 0 1.000000 -1007 0 1.000000 -1008 0 1.000000 -1009 0 1.000000 -1010 0 1.000000 -1011 0 1.000000 -1012 0 1.000000 -1013 0 1.000000 -1014 0 1.000000 -1015 0 1.000000 -1016 0 1.000000 -1017 0 1.000000 -1018 0 1.000000 -1019 0 1.000000 -1020 0 1.000000 -1021 0 1.000000 -1022 0 1.000000 -1023 0 1.000000 -1024 0 1.000000 -1025 0 1.000000 -1026 0 1.000000 -1027 0 1.000000 -1028 0 1.000000 -1029 0 1.000000 -1030 0 1.000000 -1031 0 1.000000 -1032 0 1.000000 -1033 0 1.000000 -1034 0 1.000000 -1035 0 1.000000 -1036 0 1.000000 -1037 0 1.000000 -1038 0 1.000000 -1039 0 1.000000 -1040 0 1.000000 -1041 0 1.000000 -1042 0 1.000000 -1043 0 1.000000 -1044 0 1.000000 -1045 0 1.000000 -1046 0 1.000000 -1047 0 1.000000 -1048 0 1.000000 -1049 0 1.000000 -1050 0 1.000000 -1051 0 1.000000 -1052 0 1.000000 -1053 0 1.000000 -1054 0 1.000000 -1055 0 1.000000 -1056 0 1.000000 -1057 0 1.000000 -1058 0 1.000000 -1059 0 1.000000 -1060 0 1.000000 -1061 0 1.000000 -1062 0 1.000000 -1063 0 1.000000 -1064 0 1.000000 -1065 0 1.000000 -1066 0 1.000000 -1067 0 1.000000 -1068 0 1.000000 -1069 0 1.000000 -1070 0 1.000000 -1071 0 1.000000 -1072 0 1.000000 -1073 0 1.000000 -1074 0 1.000000 -1075 0 1.000000 -1076 0 1.000000 -1077 0 1.000000 -1078 0 1.000000 -1079 0 1.000000 -1080 0 1.000000 -1081 0 1.000000 -1082 0 1.000000 -1083 0 1.000000 -1084 0 1.000000 -1085 0 1.000000 -1086 0 1.000000 -1087 0 1.000000 -1088 0 1.000000 -1089 0 1.000000 -1090 0 1.000000 -1091 0 1.000000 -1092 0 1.000000 -1093 0 1.000000 -1094 0 1.000000 -1095 0 1.000000 -1096 0 1.000000 -1097 0 1.000000 -1098 0 1.000000 -1099 0 1.000000 -1100 0 1.000000 -1101 0 1.000000 -1102 0 1.000000 -1103 0 1.000000 -1104 0 1.000000 -1105 0 1.000000 -1106 0 1.000000 -1107 0 1.000000 -1108 0 1.000000 -1109 0 1.000000 -1110 0 1.000000 -1111 0 1.000000 -1112 0 1.000000 -1113 0 1.000000 -1114 0 1.000000 -1115 0 1.000000 -1116 0 1.000000 -1117 0 1.000000 -1118 0 1.000000 -1119 0 1.000000 -1120 0 1.000000 -1121 0 1.000000 -1122 0 1.000000 -1123 0 1.000000 -1124 0 1.000000 -1125 0 1.000000 -1126 0 1.000000 -1127 0 1.000000 -1128 0 1.000000 -1129 0 1.000000 -1130 0 1.000000 -1131 0 1.000000 -1132 0 1.000000 -1133 0 1.000000 -1134 0 1.000000 -1135 0 1.000000 -1136 0 1.000000 -1137 0 1.000000 -1138 0 1.000000 -1139 0 1.000000 -1140 0 1.000000 -1141 0 1.000000 -1142 0 1.000000 -1143 0 1.000000 -1144 0 1.000000 -1145 0 1.000000 -1146 0 1.000000 -1147 0 1.000000 -1148 0 1.000000 -1149 0 1.000000 -1150 0 1.000000 -1151 0 1.000000 -1152 0 1.000000 -1153 0 1.000000 -1154 0 1.000000 -1155 0 1.000000 -1156 0 1.000000 -1157 0 1.000000 -1158 0 1.000000 -1159 0 1.000000 -1160 0 1.000000 -1161 0 1.000000 -1162 0 1.000000 -1163 0 1.000000 -1164 0 1.000000 -1165 0 1.000000 -1166 0 1.000000 -1167 0 1.000000 -1168 0 1.000000 -1169 0 1.000000 -1170 0 1.000000 -1171 0 1.000000 -1172 0 1.000000 -1173 0 1.000000 -1174 0 1.000000 -1175 0 1.000000 -1176 0 1.000000 -1177 0 1.000000 -1178 0 1.000000 -1179 0 1.000000 -1180 0 1.000000 -1181 0 1.000000 -1182 0 1.000000 -1183 0 1.000000 -1184 0 1.000000 -1185 0 1.000000 -1186 0 1.000000 -1187 0 1.000000 -1188 0 1.000000 -1189 0 1.000000 -1190 0 1.000000 -1191 0 1.000000 -1192 0 1.000000 -1193 0 1.000000 -1194 0 1.000000 -1195 0 1.000000 -1196 0 1.000000 -1197 0 1.000000 -1198 0 1.000000 -1199 0 1.000000 -1200 0 1.000000 -1201 0 1.000000 -1202 0 1.000000 -1203 0 1.000000 -1204 0 1.000000 -1205 0 1.000000 -1206 0 1.000000 -1207 0 1.000000 -1208 0 1.000000 -1209 0 1.000000 -1210 0 1.000000 -1211 0 1.000000 -1212 0 1.000000 -1213 0 1.000000 -1214 0 1.000000 -1215 0 1.000000 -1216 0 1.000000 -1217 0 1.000000 -1218 0 1.000000 -1219 0 1.000000 -1220 0 1.000000 -1221 0 1.000000 -1222 0 1.000000 -1223 0 1.000000 -1224 0 1.000000 -1225 0 1.000000 -1226 0 1.000000 -1227 0 1.000000 -1228 0 1.000000 -1229 0 1.000000 -1230 0 1.000000 -1231 0 1.000000 -1232 0 1.000000 -1233 0 1.000000 -1234 0 1.000000 -1235 0 1.000000 -1236 0 1.000000 -1237 0 1.000000 -1238 0 1.000000 -1239 0 1.000000 -1240 0 1.000000 -1241 0 1.000000 -1242 0 1.000000 -1243 0 1.000000 -1244 0 1.000000 -1245 0 1.000000 -1246 0 1.000000 -1247 0 1.000000 -1248 0 1.000000 -1249 0 1.000000 -1250 0 1.000000 -1251 0 1.000000 -1252 0 1.000000 -1253 0 1.000000 -1254 0 1.000000 -1255 0 1.000000 -1256 0 1.000000 -1257 0 1.000000 -1258 0 1.000000 -1259 0 1.000000 -1260 0 1.000000 -1261 0 1.000000 -1262 0 1.000000 -1263 0 1.000000 -1264 0 1.000000 -1265 0 1.000000 -1266 0 1.000000 -1267 0 1.000000 -1268 0 1.000000 -1269 0 1.000000 -1270 0 1.000000 -1271 0 1.000000 -1272 0 1.000000 -1273 0 1.000000 -1274 0 1.000000 -1275 0 1.000000 -1276 0 1.000000 -1277 0 1.000000 -1278 0 1.000000 -1279 0 1.000000 -1280 0 1.000000 -1281 0 1.000000 -1282 0 1.000000 -1283 0 1.000000 -1284 0 1.000000 -1285 0 1.000000 -1286 0 1.000000 -1287 0 1.000000 -1288 0 1.000000 -1289 0 1.000000 -1290 0 1.000000 -1291 0 1.000000 -1292 0 1.000000 -1293 0 1.000000 -1294 0 1.000000 -1295 0 1.000000 -1296 0 1.000000 -1297 0 1.000000 -1298 0 1.000000 -1299 0 1.000000 -1300 0 1.000000 -1301 0 1.000000 -1302 0 1.000000 -1303 0 1.000000 -1304 0 1.000000 -1305 0 1.000000 -1306 0 1.000000 -1307 0 1.000000 -1308 0 1.000000 -1309 0 1.000000 -1310 0 1.000000 -1311 0 1.000000 -1312 0 1.000000 -1313 0 1.000000 -1314 0 1.000000 -1315 0 1.000000 -1316 0 1.000000 -1317 0 1.000000 -1318 0 1.000000 -1319 0 1.000000 -1320 0 1.000000 -1321 0 1.000000 -1322 0 1.000000 -1323 0 1.000000 -1324 0 1.000000 -1325 0 1.000000 -1326 0 1.000000 -1327 0 1.000000 -1328 0 1.000000 -1329 0 1.000000 -1330 0 1.000000 -1331 0 1.000000 -1332 0 1.000000 -1333 0 1.000000 -1334 0 1.000000 -1335 0 1.000000 -1336 0 1.000000 -1337 0 1.000000 -1338 0 1.000000 -1339 0 1.000000 -1340 0 1.000000 -1341 0 1.000000 -1342 0 1.000000 -1343 0 1.000000 -1344 0 1.000000 -1345 0 1.000000 -1346 0 1.000000 -1347 0 1.000000 -1348 0 1.000000 -1349 0 1.000000 -1350 0 1.000000 -1351 0 1.000000 -1352 0 1.000000 -1353 0 1.000000 -1354 0 1.000000 -1355 0 1.000000 -1356 0 1.000000 -1357 0 1.000000 -1358 0 1.000000 -1359 0 1.000000 -1360 0 1.000000 -1361 0 1.000000 -1362 0 1.000000 -1363 0 1.000000 -1364 0 1.000000 -1365 0 1.000000 -1366 0 1.000000 -1367 0 1.000000 -1368 0 1.000000 -1369 0 1.000000 -1370 0 1.000000 -1371 0 1.000000 -1372 0 1.000000 -1373 0 1.000000 -1374 0 1.000000 -1375 0 1.000000 -1376 0 1.000000 -1377 0 1.000000 -1378 0 1.000000 -1379 0 1.000000 -1380 0 1.000000 -1381 0 1.000000 -1382 0 1.000000 -1383 0 1.000000 -1384 0 1.000000 -1385 0 1.000000 -1386 0 1.000000 -1387 0 1.000000 -1388 0 1.000000 -1389 0 1.000000 -1390 0 1.000000 -1391 0 1.000000 -1392 0 1.000000 -1393 0 1.000000 -1394 0 1.000000 -1395 0 1.000000 -1396 0 1.000000 -1397 0 1.000000 -1398 0 1.000000 -1399 0 1.000000 -1400 0 1.000000 -1401 0 1.000000 -1402 0 1.000000 -1403 0 1.000000 -1404 0 1.000000 -1405 0 1.000000 -1406 0 1.000000 -1407 0 1.000000 -1408 0 1.000000 -1409 0 1.000000 -1410 0 1.000000 -1411 0 1.000000 -1412 0 1.000000 -1413 0 1.000000 -1414 0 1.000000 -1415 0 1.000000 -1416 0 1.000000 -1417 0 1.000000 -1418 0 1.000000 -1419 0 1.000000 -1420 0 1.000000 -1421 0 1.000000 -1422 0 1.000000 -1423 0 1.000000 -1424 0 1.000000 -1425 0 1.000000 -1426 0 1.000000 -1427 0 1.000000 -1428 0 1.000000 -1429 0 1.000000 -1430 0 1.000000 -1431 0 1.000000 -1432 0 1.000000 -1433 0 1.000000 -1434 0 1.000000 -1435 0 1.000000 -1436 0 1.000000 -1437 0 1.000000 -1438 0 1.000000 -1439 0 1.000000 -1440 0 1.000000 -1441 0 1.000000 -1442 0 1.000000 -1443 0 1.000000 -1444 0 1.000000 -1445 0 1.000000 -1446 0 1.000000 -1447 0 1.000000 -1448 0 1.000000 -1449 0 1.000000 -1450 0 1.000000 -1451 0 1.000000 -1452 0 1.000000 -1453 0 1.000000 -1454 0 1.000000 -1455 0 1.000000 -1456 0 1.000000 -1457 0 1.000000 -1458 0 1.000000 -1459 0 1.000000 -1460 0 1.000000 -1461 0 1.000000 -1462 0 1.000000 -1463 0 1.000000 -1464 0 1.000000 -1465 0 1.000000 -1466 0 1.000000 -1467 0 1.000000 -1468 0 1.000000 -1469 0 1.000000 -1470 0 1.000000 -1471 0 1.000000 -1472 0 1.000000 -1473 0 1.000000 -1474 0 1.000000 -1475 0 1.000000 -1476 0 1.000000 -1477 0 1.000000 -1478 0 1.000000 -1479 0 1.000000 -1480 0 1.000000 -1481 0 1.000000 -1482 0 1.000000 -1483 0 1.000000 -1484 0 1.000000 -1485 0 1.000000 -1486 0 1.000000 -1487 0 1.000000 -1488 0 1.000000 -1489 0 1.000000 -1490 0 1.000000 -1491 0 1.000000 -1492 0 1.000000 -1493 0 1.000000 -1494 0 1.000000 -1495 0 1.000000 -1496 0 1.000000 -1497 0 1.000000 -1498 0 1.000000 -1499 0 1.000000 -1500 0 1.000000 -1501 0 1.000000 -1502 0 1.000000 -1503 0 1.000000 -1504 0 1.000000 -1505 0 1.000000 -1506 0 1.000000 -1507 0 1.000000 -1508 0 1.000000 -1509 0 1.000000 -1510 0 1.000000 -1511 0 1.000000 -1512 0 1.000000 -1513 0 1.000000 -1514 0 1.000000 -1515 0 1.000000 -1516 0 1.000000 -1517 0 1.000000 -1518 0 1.000000 -1519 0 1.000000 -1520 0 1.000000 -1521 0 1.000000 -1522 0 1.000000 -1523 0 1.000000 -1524 0 1.000000 -1525 0 1.000000 -1526 0 1.000000 -1527 0 1.000000 -1528 0 1.000000 -1529 0 1.000000 -1530 0 1.000000 -1531 0 1.000000 -1532 0 1.000000 -1533 0 1.000000 -1534 0 1.000000 -1535 0 1.000000 -1536 0 1.000000 -1537 0 1.000000 -1538 0 1.000000 -1539 0 1.000000 -1540 0 1.000000 -1541 0 1.000000 -1542 0 1.000000 -1543 0 1.000000 -1544 0 1.000000 -1545 0 1.000000 -1546 0 1.000000 -1547 0 1.000000 -1548 0 1.000000 -1549 0 1.000000 -1550 0 1.000000 -1551 0 1.000000 -1552 0 1.000000 -1553 0 1.000000 -1554 0 1.000000 -1555 0 1.000000 -1556 0 1.000000 -1557 0 1.000000 -1558 0 1.000000 -1559 0 1.000000 -1560 0 1.000000 -1561 0 1.000000 -1562 0 1.000000 -1563 0 1.000000 -1564 0 1.000000 -1565 0 1.000000 -1566 0 1.000000 -1567 0 1.000000 -1568 0 1.000000 -1569 0 1.000000 -1570 0 1.000000 -1571 0 1.000000 -1572 0 1.000000 -1573 0 1.000000 -1574 0 1.000000 -1575 0 1.000000 -1576 0 1.000000 -1577 0 1.000000 -1578 0 1.000000 -1579 0 1.000000 -1580 0 1.000000 -1581 0 1.000000 -1582 0 1.000000 -1583 0 1.000000 -1584 0 1.000000 -1585 0 1.000000 -1586 0 1.000000 -1587 0 1.000000 -1588 0 1.000000 -1589 0 1.000000 -1590 0 1.000000 -1591 0 1.000000 -1592 0 1.000000 -1593 0 1.000000 -1594 0 1.000000 -1595 0 1.000000 -1596 0 1.000000 -1597 0 1.000000 -1598 0 1.000000 -1599 0 1.000000 -1600 0 1.000000 -1601 0 1.000000 -1602 0 1.000000 -1603 0 1.000000 -1604 0 1.000000 -1605 0 1.000000 -1606 0 1.000000 -1607 0 1.000000 -1608 0 1.000000 -1609 0 1.000000 -1610 0 1.000000 -1611 0 1.000000 -1612 0 1.000000 -1613 0 1.000000 -1614 0 1.000000 -1615 0 1.000000 -1616 0 1.000000 -1617 0 1.000000 -1618 0 1.000000 -1619 0 1.000000 -1620 0 1.000000 -1621 0 1.000000 -1622 0 1.000000 -1623 0 1.000000 -1624 0 1.000000 -1625 0 1.000000 -1626 0 1.000000 -1627 0 1.000000 -1628 0 1.000000 -1629 0 1.000000 -1630 0 1.000000 -1631 0 1.000000 -1632 0 1.000000 -1633 0 1.000000 -1634 0 1.000000 -1635 0 1.000000 -1636 0 1.000000 -1637 0 1.000000 -1638 0 1.000000 -1639 0 1.000000 -1640 0 1.000000 -1641 0 1.000000 -1642 0 1.000000 -1643 0 1.000000 -1644 0 1.000000 -1645 0 1.000000 -1646 0 1.000000 -1647 0 1.000000 -1648 0 1.000000 -1649 0 1.000000 -1650 0 1.000000 -1651 0 1.000000 -1652 0 1.000000 -1653 0 1.000000 -1654 0 1.000000 -1655 0 1.000000 -1656 0 1.000000 -1657 0 1.000000 -1658 0 1.000000 -1659 0 1.000000 -1660 0 1.000000 -1661 0 1.000000 -1662 0 1.000000 -1663 0 1.000000 -1664 0 1.000000 -1665 0 1.000000 -1666 0 1.000000 -1667 0 1.000000 -1668 0 1.000000 -1669 0 1.000000 -1670 0 1.000000 -1671 0 1.000000 -1672 0 1.000000 -1673 0 1.000000 -1674 0 1.000000 -1675 0 1.000000 -1676 0 1.000000 -1677 0 1.000000 -1678 0 1.000000 -1679 0 1.000000 -1680 0 1.000000 -1681 0 1.000000 -1682 0 1.000000 -1683 0 1.000000 -1684 0 1.000000 -1685 0 1.000000 -1686 0 1.000000 -1687 0 1.000000 -1688 0 1.000000 -1689 0 1.000000 -1690 0 1.000000 -1691 0 1.000000 -1692 0 1.000000 -1693 0 1.000000 -1694 0 1.000000 -1695 0 1.000000 -1696 0 1.000000 -1697 0 1.000000 -1698 0 1.000000 -1699 0 1.000000 -1700 0 1.000000 -1701 0 1.000000 -1702 0 1.000000 -1703 0 1.000000 -1704 0 1.000000 -1705 0 1.000000 -1706 0 1.000000 -1707 0 1.000000 -1708 0 1.000000 -1709 0 1.000000 -1710 0 1.000000 -1711 0 1.000000 -1712 0 1.000000 -1713 0 1.000000 -1714 0 1.000000 -1715 0 1.000000 -1716 0 1.000000 -1717 0 1.000000 -1718 0 1.000000 -1719 0 1.000000 -1720 0 1.000000 -1721 0 1.000000 -1722 0 1.000000 -1723 0 1.000000 -1724 0 1.000000 -1725 0 1.000000 -1726 0 1.000000 -1727 0 1.000000 -1728 0 1.000000 -1729 0 1.000000 -1730 0 1.000000 -1731 0 1.000000 -1732 0 1.000000 -1733 0 1.000000 -1734 0 1.000000 -1735 0 1.000000 -1736 0 1.000000 -1737 0 1.000000 -1738 0 1.000000 -1739 0 1.000000 -1740 0 1.000000 -1741 0 1.000000 -1742 0 1.000000 -1743 0 1.000000 -1744 0 1.000000 -1745 0 1.000000 -1746 0 1.000000 -1747 0 1.000000 -1748 0 1.000000 -1749 0 1.000000 -1750 0 1.000000 -1751 0 1.000000 -1752 0 1.000000 -1753 0 1.000000 -1754 0 1.000000 -1755 0 1.000000 -1756 0 1.000000 -1757 0 1.000000 -1758 0 1.000000 -1759 0 1.000000 -1760 0 1.000000 -1761 0 1.000000 -1762 0 1.000000 -1763 0 1.000000 -1764 0 1.000000 -1765 0 1.000000 -1766 0 1.000000 -1767 0 1.000000 -1768 0 1.000000 -1769 0 1.000000 -1770 0 1.000000 -1771 0 1.000000 -1772 0 1.000000 -1773 0 1.000000 -1774 0 1.000000 -1775 0 1.000000 -1776 0 1.000000 -1777 0 1.000000 -1778 0 1.000000 -1779 0 1.000000 -1780 0 1.000000 -1781 0 1.000000 -1782 0 1.000000 -1783 0 1.000000 -1784 0 1.000000 -1785 0 1.000000 -1786 0 1.000000 -1787 0 1.000000 -1788 0 1.000000 -1789 0 1.000000 -1790 0 1.000000 -1791 0 1.000000 -1792 0 1.000000 -1793 0 1.000000 -1794 0 1.000000 -1795 0 1.000000 -1796 0 1.000000 -1797 0 1.000000 -1798 0 1.000000 -1799 0 1.000000 -1800 0 1.000000 -1801 0 1.000000 -1802 0 1.000000 -1803 0 1.000000 -1804 0 1.000000 -1805 0 1.000000 -1806 0 1.000000 -1807 0 1.000000 -1808 0 1.000000 -1809 0 1.000000 -1810 0 1.000000 -1811 0 1.000000 -1812 0 1.000000 -1813 0 1.000000 -1814 0 1.000000 -1815 0 1.000000 -1816 0 1.000000 -1817 0 1.000000 -1818 0 1.000000 -1819 0 1.000000 -1820 0 1.000000 -1821 0 1.000000 -1822 0 1.000000 -1823 0 1.000000 -1824 0 1.000000 -1825 0 1.000000 -1826 0 1.000000 -1827 0 1.000000 -1828 0 1.000000 -1829 0 1.000000 -1830 0 1.000000 -1831 0 1.000000 -1832 0 1.000000 -1833 0 1.000000 -1834 0 1.000000 -1835 0 1.000000 -1836 0 1.000000 -1837 0 1.000000 -1838 0 1.000000 -1839 0 1.000000 -1840 0 1.000000 -1841 0 1.000000 -1842 0 1.000000 -1843 0 1.000000 -1844 0 1.000000 -1845 0 1.000000 -1846 0 1.000000 -1847 0 1.000000 -1848 0 1.000000 -1849 0 1.000000 -1850 0 1.000000 -1851 0 1.000000 -1852 0 1.000000 -1853 0 1.000000 -1854 0 1.000000 -1855 0 1.000000 -1856 0 1.000000 -1857 0 1.000000 -1858 0 1.000000 -1859 0 1.000000 -1860 0 1.000000 -1861 0 1.000000 -1862 0 1.000000 -1863 0 1.000000 -1864 0 1.000000 -1865 0 1.000000 -1866 0 1.000000 -1867 0 1.000000 -1868 0 1.000000 -1869 0 1.000000 -1870 0 1.000000 -1871 0 1.000000 -1872 0 1.000000 -1873 0 1.000000 -1874 0 1.000000 -1875 0 1.000000 -1876 0 1.000000 -1877 0 1.000000 -1878 0 1.000000 -1879 0 1.000000 -1880 0 1.000000 -1881 0 1.000000 -1882 0 1.000000 -1883 0 1.000000 -1884 0 1.000000 -1885 0 1.000000 -1886 0 1.000000 -1887 0 1.000000 -1888 0 1.000000 -1889 0 1.000000 -1890 0 1.000000 -1891 0 1.000000 -1892 0 1.000000 -1893 0 1.000000 -1894 0 1.000000 -1895 0 1.000000 -1896 0 1.000000 -1897 0 1.000000 -1898 0 1.000000 -1899 0 1.000000 -1900 0 1.000000 -1901 0 1.000000 -1902 0 1.000000 -1903 0 1.000000 -1904 0 1.000000 -1905 0 1.000000 -1906 0 1.000000 -1907 0 1.000000 -1908 0 1.000000 -1909 0 1.000000 -1910 0 1.000000 -1911 0 1.000000 -1912 0 1.000000 -1913 0 1.000000 -1914 0 1.000000 -1915 0 1.000000 -1916 0 1.000000 -1917 0 1.000000 -1918 0 1.000000 -1919 0 1.000000 -1920 0 1.000000 -1921 0 1.000000 -1922 0 1.000000 -1923 0 1.000000 -1924 0 1.000000 -1925 0 1.000000 -1926 0 1.000000 -1927 0 1.000000 -1928 0 1.000000 -1929 0 1.000000 -1930 0 1.000000 -1931 0 1.000000 -1932 0 1.000000 -1933 0 1.000000 -1934 0 1.000000 -1935 0 1.000000 -1936 0 1.000000 -1937 0 1.000000 -1938 0 1.000000 -1939 0 1.000000 -1940 0 1.000000 -1941 0 1.000000 -1942 0 1.000000 -1943 0 1.000000 -1944 0 1.000000 -1945 0 1.000000 -1946 0 1.000000 -1947 0 1.000000 -1948 0 1.000000 -1949 0 1.000000 -1950 0 1.000000 -1951 0 1.000000 -1952 0 1.000000 -1953 0 1.000000 -1954 0 1.000000 -1955 0 1.000000 -1956 0 1.000000 -1957 0 1.000000 -1958 0 1.000000 -1959 0 1.000000 -1960 0 1.000000 -1961 0 1.000000 -1962 0 1.000000 -1963 0 1.000000 -1964 0 1.000000 -1965 0 1.000000 -1966 0 1.000000 -1967 0 1.000000 -1968 0 1.000000 -1969 0 1.000000 -1970 0 1.000000 -1971 0 1.000000 -1972 0 1.000000 -1973 0 1.000000 -1974 0 1.000000 -1975 0 1.000000 -1976 0 1.000000 -1977 0 1.000000 -1978 0 1.000000 -1979 0 1.000000 -1980 0 1.000000 -1981 0 1.000000 -1982 0 1.000000 -1983 0 1.000000 -1984 0 1.000000 -1985 0 1.000000 -1986 0 1.000000 -1987 0 1.000000 -1988 0 1.000000 -1989 0 1.000000 -1990 0 1.000000 -1991 0 1.000000 -1992 0 1.000000 -1993 0 1.000000 -1994 0 1.000000 -1995 0 1.000000 -1996 0 1.000000 -1997 0 1.000000 -1998 0 1.000000 -1999 0 1.000000 -2000 0 1.000000 -2001 0 1.000000 -2002 0 1.000000 -2003 0 1.000000 -2004 0 1.000000 -2005 0 1.000000 -2006 0 1.000000 -2007 0 1.000000 -2008 0 1.000000 -2009 0 1.000000 -2010 0 1.000000 -2011 0 1.000000 -2012 0 1.000000 -2013 0 1.000000 -2014 0 1.000000 -2015 0 1.000000 -2016 0 1.000000 -2017 0 1.000000 -2018 0 1.000000 -2019 0 1.000000 -2020 0 1.000000 -2021 0 1.000000 -2022 0 1.000000 -2023 0 1.000000 -2024 0 1.000000 -2025 0 1.000000 -2026 0 1.000000 -2027 0 1.000000 -2028 0 1.000000 -2029 0 1.000000 -2030 0 1.000000 -2031 0 1.000000 -2032 0 1.000000 -2033 0 1.000000 -2034 0 1.000000 -2035 0 1.000000 -2036 0 1.000000 -2037 0 1.000000 -2038 0 1.000000 -2039 0 1.000000 -2040 0 1.000000 -2041 0 1.000000 -2042 0 1.000000 -2043 0 1.000000 -2044 0 1.000000 -2045 0 1.000000 -2046 0 1.000000 -2047 0 1.000000 -2048 0 1.000000 -2049 0 1.000000 -2050 0 1.000000 -2051 0 1.000000 -2052 0 1.000000 -2053 0 1.000000 -2054 0 1.000000 -2055 0 1.000000 -2056 0 1.000000 -2057 0 1.000000 -2058 0 1.000000 -2059 0 1.000000 -2060 0 1.000000 -2061 0 1.000000 -2062 0 1.000000 -2063 0 1.000000 -2064 0 1.000000 -2065 0 1.000000 -2066 0 1.000000 -2067 0 1.000000 -2068 0 1.000000 -2069 0 1.000000 -2070 0 1.000000 -2071 0 1.000000 -2072 0 1.000000 -2073 0 1.000000 -2074 0 1.000000 -2075 0 1.000000 -2076 0 1.000000 -2077 0 1.000000 -2078 0 1.000000 -2079 0 1.000000 -2080 0 1.000000 -2081 0 1.000000 -2082 0 1.000000 -2083 0 1.000000 -2084 0 1.000000 -2085 0 1.000000 -2086 0 1.000000 -2087 0 1.000000 -2088 0 1.000000 -2089 0 1.000000 -2090 0 1.000000 -2091 0 1.000000 -2092 0 1.000000 -2093 0 1.000000 -2094 0 1.000000 -2095 0 1.000000 -2096 0 1.000000 -2097 0 1.000000 -2098 0 1.000000 -2099 0 1.000000 -2100 0 1.000000 -2101 0 1.000000 -2102 0 1.000000 -2103 0 1.000000 -2104 0 1.000000 -2105 0 1.000000 -2106 0 1.000000 -2107 0 1.000000 -2108 0 1.000000 -2109 0 1.000000 -2110 0 1.000000 -2111 0 1.000000 -2112 0 1.000000 -2113 0 1.000000 -2114 0 1.000000 -2115 0 1.000000 -2116 0 1.000000 -2117 0 1.000000 -2118 0 1.000000 -2119 0 1.000000 -2120 0 1.000000 -2121 0 1.000000 -2122 0 1.000000 -2123 0 1.000000 -2124 0 1.000000 -2125 0 1.000000 -2126 0 1.000000 -2127 0 1.000000 -2128 0 1.000000 -2129 0 1.000000 -2130 0 1.000000 -2131 0 1.000000 -2132 0 1.000000 -2133 0 1.000000 -2134 0 1.000000 -2135 0 1.000000 -2136 0 1.000000 -2137 0 1.000000 -2138 0 1.000000 -2139 0 1.000000 -2140 0 1.000000 -2141 0 1.000000 -2142 0 1.000000 -2143 0 1.000000 -2144 0 1.000000 -2145 0 1.000000 -2146 0 1.000000 -2147 0 1.000000 -2148 0 1.000000 -2149 0 1.000000 -2150 0 1.000000 -2151 0 1.000000 -2152 0 1.000000 -2153 0 1.000000 -2154 0 1.000000 -2155 0 1.000000 -2156 0 1.000000 -2157 0 1.000000 -2158 0 1.000000 -2159 0 1.000000 -2160 0 1.000000 -2161 0 1.000000 -2162 0 1.000000 -2163 0 1.000000 -2164 0 1.000000 -2165 0 1.000000 -2166 0 1.000000 -2167 0 1.000000 -2168 0 1.000000 -2169 0 1.000000 -2170 0 1.000000 -2171 0 1.000000 -2172 0 1.000000 -2173 0 1.000000 -2174 0 1.000000 -2175 0 1.000000 -2176 0 1.000000 -2177 0 1.000000 -2178 0 1.000000 -2179 0 1.000000 -2180 0 1.000000 -2181 0 1.000000 -2182 0 1.000000 -2183 0 1.000000 -2184 0 1.000000 -2185 0 1.000000 -2186 0 1.000000 -2187 0 1.000000 -2188 0 1.000000 -2189 0 1.000000 -2190 0 1.000000 -2191 0 1.000000 -2192 0 1.000000 -2193 0 1.000000 -2194 0 1.000000 -2195 0 1.000000 -2196 0 1.000000 -2197 0 1.000000 -2198 0 1.000000 -2199 0 1.000000 -2200 0 1.000000 -2201 0 1.000000 -2202 0 1.000000 -2203 0 1.000000 -2204 0 1.000000 -2205 0 1.000000 -2206 0 1.000000 -2207 0 1.000000 -2208 0 1.000000 -2209 0 1.000000 -2210 0 1.000000 -2211 0 1.000000 -2212 0 1.000000 -2213 0 1.000000 -2214 0 1.000000 -2215 0 1.000000 -2216 0 1.000000 -2217 0 1.000000 -2218 0 1.000000 -2219 0 1.000000 -2220 0 1.000000 -2221 0 1.000000 -2222 0 1.000000 -2223 0 1.000000 -2224 0 1.000000 -2225 0 1.000000 -2226 0 1.000000 -2227 0 1.000000 -2228 0 1.000000 -2229 0 1.000000 -2230 0 1.000000 -2231 0 1.000000 -2232 0 1.000000 -2233 0 1.000000 -2234 0 1.000000 -2235 0 1.000000 -2236 0 1.000000 -2237 0 1.000000 -2238 0 1.000000 -2239 0 1.000000 -2240 0 1.000000 -2241 0 1.000000 -2242 0 1.000000 -2243 0 1.000000 -2244 0 1.000000 -2245 0 1.000000 -2246 0 1.000000 -2247 0 1.000000 -2248 0 1.000000 -2249 0 1.000000 -2250 0 1.000000 -2251 0 1.000000 -2252 0 1.000000 -2253 0 1.000000 -2254 0 1.000000 -2255 0 1.000000 -2256 0 1.000000 -2257 0 1.000000 -2258 0 1.000000 -2259 0 1.000000 -2260 0 1.000000 -2261 0 1.000000 -2262 0 1.000000 -2263 0 1.000000 -2264 0 1.000000 -2265 0 1.000000 -2266 0 1.000000 -2267 0 1.000000 -2268 0 1.000000 -2269 0 1.000000 -2270 0 1.000000 -2271 0 1.000000 -2272 0 1.000000 -2273 0 1.000000 -2274 0 1.000000 -2275 0 1.000000 -2276 0 1.000000 -2277 0 1.000000 -2278 0 1.000000 -2279 0 1.000000 -2280 0 1.000000 -2281 0 1.000000 -2282 0 1.000000 -2283 0 1.000000 -2284 0 1.000000 -2285 0 1.000000 -2286 0 1.000000 -2287 0 1.000000 -2288 0 1.000000 -2289 0 1.000000 -2290 0 1.000000 -2291 0 1.000000 -2292 0 1.000000 -2293 0 1.000000 -2294 0 1.000000 -2295 0 1.000000 -2296 0 1.000000 -2297 0 1.000000 -2298 0 1.000000 -2299 0 1.000000 -2300 0 1.000000 -2301 0 1.000000 -2302 0 1.000000 -2303 0 1.000000 -2304 0 1.000000 -2305 0 1.000000 -2306 0 1.000000 -2307 0 1.000000 -2308 0 1.000000 -2309 0 1.000000 -2310 0 1.000000 -2311 0 1.000000 -2312 0 1.000000 -2313 0 1.000000 -2314 0 1.000000 -2315 0 1.000000 -2316 0 1.000000 -2317 0 1.000000 -2318 0 1.000000 -2319 0 1.000000 -2320 0 1.000000 -2321 0 1.000000 -2322 0 1.000000 -2323 0 1.000000 -2324 0 1.000000 -2325 0 1.000000 -2326 0 1.000000 -2327 0 1.000000 -2328 0 1.000000 -2329 0 1.000000 -2330 0 1.000000 -2331 0 1.000000 -2332 0 1.000000 -2333 0 1.000000 -2334 0 1.000000 -2335 0 1.000000 -2336 0 1.000000 -2337 0 1.000000 -2338 0 1.000000 -2339 0 1.000000 -2340 0 1.000000 -2341 0 1.000000 -2342 0 1.000000 -2343 0 1.000000 -2344 0 1.000000 -2345 0 1.000000 -2346 0 1.000000 -2347 0 1.000000 -2348 0 1.000000 -2349 0 1.000000 -2350 0 1.000000 -2351 0 1.000000 -2352 0 1.000000 -2353 0 1.000000 -2354 0 1.000000 -2355 0 1.000000 -2356 0 1.000000 -2357 0 1.000000 -2358 0 1.000000 -2359 0 1.000000 -2360 0 1.000000 -2361 0 1.000000 -2362 0 1.000000 -2363 0 1.000000 -2364 0 1.000000 -2365 0 1.000000 -2366 0 1.000000 -2367 0 1.000000 -2368 0 1.000000 -2369 0 1.000000 -2370 0 1.000000 -2371 0 1.000000 -2372 0 1.000000 -2373 0 1.000000 -2374 0 1.000000 -2375 0 1.000000 -2376 0 1.000000 -2377 0 1.000000 -2378 0 1.000000 -2379 0 1.000000 -2380 0 1.000000 -2381 0 1.000000 -2382 0 1.000000 -2383 0 1.000000 -2384 0 1.000000 -2385 0 1.000000 -2386 0 1.000000 -2387 0 1.000000 -2388 0 1.000000 -2389 0 1.000000 -2390 0 1.000000 -2391 0 1.000000 -2392 0 1.000000 -2393 0 1.000000 -2394 0 1.000000 -2395 0 1.000000 -2396 0 1.000000 -2397 0 1.000000 -2398 0 1.000000 -2399 0 1.000000 -2400 0 1.000000 -2401 0 1.000000 -2402 0 1.000000 -2403 0 1.000000 -2404 0 1.000000 -2405 0 1.000000 -2406 0 1.000000 -2407 0 1.000000 -2408 0 1.000000 -2409 0 1.000000 -2410 0 1.000000 -2411 0 1.000000 -2412 0 1.000000 -2413 0 1.000000 -2414 0 1.000000 -2415 0 1.000000 -2416 0 1.000000 -2417 0 1.000000 -2418 0 1.000000 -2419 0 1.000000 -2420 0 1.000000 -2421 0 1.000000 -2422 0 1.000000 -2423 0 1.000000 -2424 0 1.000000 -2425 0 1.000000 -2426 0 1.000000 -2427 0 1.000000 -2428 0 1.000000 -2429 0 1.000000 -2430 0 1.000000 -2431 0 1.000000 -2432 0 1.000000 -2433 0 1.000000 -2434 0 1.000000 -2435 0 1.000000 -2436 0 1.000000 -2437 0 1.000000 -2438 0 1.000000 -2439 0 1.000000 -2440 0 1.000000 -2441 0 1.000000 -2442 0 1.000000 -2443 0 1.000000 -2444 0 1.000000 -2445 0 1.000000 -2446 0 1.000000 -2447 0 1.000000 -2448 0 1.000000 -2449 0 1.000000 -2450 0 1.000000 -2451 0 1.000000 -2452 0 1.000000 -2453 0 1.000000 -2454 0 1.000000 -2455 0 1.000000 -2456 0 1.000000 -2457 0 1.000000 -2458 0 1.000000 -2459 0 1.000000 -2460 0 1.000000 -2461 0 1.000000 -2462 0 1.000000 -2463 0 1.000000 -2464 0 1.000000 -2465 0 1.000000 -2466 0 1.000000 -2467 0 1.000000 -2468 0 1.000000 -2469 0 1.000000 -2470 0 1.000000 -2471 0 1.000000 -2472 0 1.000000 -2473 0 1.000000 -2474 0 1.000000 -2475 0 1.000000 -2476 0 1.000000 -2477 0 1.000000 -2478 0 1.000000 -2479 0 1.000000 -2480 0 1.000000 -2481 0 1.000000 -2482 0 1.000000 -2483 0 1.000000 -2484 0 1.000000 -2485 0 1.000000 -2486 0 1.000000 -2487 0 1.000000 -2488 0 1.000000 -2489 0 1.000000 -2490 0 1.000000 -2491 0 1.000000 -2492 0 1.000000 -2493 0 1.000000 -2494 0 1.000000 -2495 0 1.000000 -2496 0 1.000000 -2497 0 1.000000 -2498 0 1.000000 -2499 0 1.000000 -2500 0 1.000000 -2501 0 1.000000 -2502 0 1.000000 -2503 0 1.000000 -2504 0 1.000000 -2505 0 1.000000 -2506 0 1.000000 -2507 0 1.000000 -2508 0 1.000000 -2509 0 1.000000 -2510 0 1.000000 -2511 0 1.000000 -2512 0 1.000000 -2513 0 1.000000 -2514 0 1.000000 -2515 0 1.000000 -2516 0 1.000000 -2517 0 1.000000 -2518 0 1.000000 -2519 0 1.000000 -2520 0 1.000000 -2521 0 1.000000 -2522 0 1.000000 -2523 0 1.000000 -2524 0 1.000000 -2525 0 1.000000 -2526 0 1.000000 -2527 0 1.000000 -2528 0 1.000000 -2529 0 1.000000 -2530 0 1.000000 -2531 0 1.000000 -2532 0 1.000000 -2533 0 1.000000 -2534 0 1.000000 -2535 0 1.000000 -2536 0 1.000000 -2537 0 1.000000 -2538 0 1.000000 -2539 0 1.000000 -2540 0 1.000000 -2541 0 1.000000 -2542 0 1.000000 -2543 0 1.000000 -2544 0 1.000000 -2545 0 1.000000 -2546 0 1.000000 -2547 0 1.000000 -2548 0 1.000000 -2549 0 1.000000 -2550 0 1.000000 -2551 0 1.000000 -2552 0 1.000000 -2553 0 1.000000 -2554 0 1.000000 -2555 0 1.000000 -2556 0 1.000000 -2557 0 1.000000 -2558 0 1.000000 -2559 0 1.000000 -2560 0 1.000000 -2561 0 1.000000 -2562 0 1.000000 -2563 0 1.000000 -2564 0 1.000000 -2565 0 1.000000 -2566 0 1.000000 -2567 0 1.000000 -2568 0 1.000000 -2569 0 1.000000 -2570 0 1.000000 -2571 0 1.000000 -2572 0 1.000000 -2573 0 1.000000 -2574 0 1.000000 -2575 0 1.000000 -2576 0 1.000000 -2577 0 1.000000 -2578 0 1.000000 -2579 0 1.000000 -2580 0 1.000000 -2581 0 1.000000 -2582 0 1.000000 -2583 0 1.000000 -2584 0 1.000000 -2585 0 1.000000 -2586 0 1.000000 -2587 0 1.000000 -2588 0 1.000000 -2589 0 1.000000 -2590 0 1.000000 -2591 0 1.000000 -2592 0 1.000000 -2593 0 1.000000 -2594 0 1.000000 -2595 0 1.000000 -2596 0 1.000000 -2597 0 1.000000 -2598 0 1.000000 -2599 0 1.000000 -2600 0 1.000000 -2601 0 1.000000 -2602 0 1.000000 -2603 0 1.000000 -2604 0 1.000000 -2605 0 1.000000 -2606 0 1.000000 -2607 0 1.000000 -2608 0 1.000000 -2609 0 1.000000 -2610 0 1.000000 -2611 0 1.000000 -2612 0 1.000000 -2613 0 1.000000 -2614 0 1.000000 -2615 0 1.000000 -2616 0 1.000000 -2617 0 1.000000 -2618 0 1.000000 -2619 0 1.000000 -2620 0 1.000000 -2621 0 1.000000 -2622 0 1.000000 -2623 0 1.000000 -2624 0 1.000000 -2625 0 1.000000 -2626 0 1.000000 -2627 0 1.000000 -2628 0 1.000000 -2629 0 1.000000 -2630 0 1.000000 -2631 0 1.000000 -2632 0 1.000000 -2633 0 1.000000 -2634 0 1.000000 -2635 0 1.000000 -2636 0 1.000000 -2637 0 1.000000 -2638 0 1.000000 -2639 0 1.000000 -2640 0 1.000000 -2641 0 1.000000 -2642 0 1.000000 -2643 0 1.000000 -2644 0 1.000000 -2645 0 1.000000 -2646 0 1.000000 -2647 0 1.000000 -2648 0 1.000000 -2649 0 1.000000 -2650 0 1.000000 -2651 0 1.000000 -2652 0 1.000000 -2653 0 1.000000 -2654 0 1.000000 -2655 0 1.000000 -2656 0 1.000000 -2657 0 1.000000 -2658 0 1.000000 -2659 0 1.000000 -2660 0 1.000000 -2661 0 1.000000 -2662 0 1.000000 -2663 0 1.000000 -2664 0 1.000000 -2665 0 1.000000 -2666 0 1.000000 -2667 0 1.000000 -2668 0 1.000000 -2669 0 1.000000 -2670 0 1.000000 -2671 0 1.000000 -2672 0 1.000000 -2673 0 1.000000 -2674 0 1.000000 -2675 0 1.000000 -2676 0 1.000000 -2677 0 1.000000 -2678 0 1.000000 -2679 0 1.000000 -2680 0 1.000000 -2681 0 1.000000 -2682 0 1.000000 -2683 0 1.000000 -2684 0 1.000000 -2685 0 1.000000 -2686 0 1.000000 -2687 0 1.000000 -2688 0 1.000000 -2689 0 1.000000 -2690 0 1.000000 -2691 0 1.000000 -2692 0 1.000000 -2693 0 1.000000 -2694 0 1.000000 -2695 0 1.000000 -2696 0 1.000000 -2697 0 1.000000 -2698 0 1.000000 -2699 0 1.000000 -2700 0 1.000000 -2701 0 1.000000 -2702 0 1.000000 -2703 0 1.000000 -2704 0 1.000000 -2705 0 1.000000 -2706 0 1.000000 -2707 0 1.000000 -2708 0 1.000000 -2709 0 1.000000 -2710 0 1.000000 -2711 0 1.000000 -2712 0 1.000000 -2713 0 1.000000 -2714 0 1.000000 -2715 0 1.000000 -2716 0 1.000000 -2717 0 1.000000 -2718 0 1.000000 -2719 0 1.000000 -2720 0 1.000000 -2721 0 1.000000 -2722 0 1.000000 -2723 0 1.000000 -2724 0 1.000000 -2725 0 1.000000 -2726 0 1.000000 -2727 0 1.000000 -2728 0 1.000000 -2729 0 1.000000 -2730 0 1.000000 -2731 0 1.000000 -2732 0 1.000000 -2733 0 1.000000 -2734 0 1.000000 -2735 0 1.000000 -2736 0 1.000000 -2737 0 1.000000 -2738 0 1.000000 -2739 0 1.000000 -2740 0 1.000000 -2741 0 1.000000 -2742 0 1.000000 -2743 0 1.000000 -2744 0 1.000000 -2745 0 1.000000 -2746 0 1.000000 -2747 0 1.000000 -2748 0 1.000000 -2749 0 1.000000 -2750 0 1.000000 -2751 0 1.000000 -2752 0 1.000000 -2753 0 1.000000 -2754 0 1.000000 -2755 0 1.000000 -2756 0 1.000000 -2757 0 1.000000 -2758 0 1.000000 -2759 0 1.000000 -2760 0 1.000000 -2761 0 1.000000 -2762 0 1.000000 -2763 0 1.000000 -2764 0 1.000000 -2765 0 1.000000 -2766 0 1.000000 -2767 0 1.000000 -2768 0 1.000000 -2769 0 1.000000 -2770 0 1.000000 -2771 0 1.000000 -2772 0 1.000000 -2773 0 1.000000 -2774 0 1.000000 -2775 0 1.000000 -2776 0 1.000000 -2777 0 1.000000 -2778 0 1.000000 -2779 0 1.000000 -2780 0 1.000000 -2781 0 1.000000 -2782 0 1.000000 -2783 0 1.000000 -2784 0 1.000000 -2785 0 1.000000 -2786 0 1.000000 -2787 0 1.000000 -2788 0 1.000000 -2789 0 1.000000 -2790 0 1.000000 -2791 0 1.000000 -2792 0 1.000000 -2793 0 1.000000 -2794 0 1.000000 -2795 0 1.000000 -2796 0 1.000000 -2797 0 1.000000 -2798 0 1.000000 -2799 0 1.000000 -2800 0 1.000000 -2801 0 1.000000 -2802 0 1.000000 -2803 0 1.000000 -2804 0 1.000000 -2805 0 1.000000 -2806 0 1.000000 -2807 0 1.000000 -2808 0 1.000000 -2809 0 1.000000 -2810 0 1.000000 -2811 0 1.000000 -2812 0 1.000000 -2813 0 1.000000 -2814 0 1.000000 -2815 0 1.000000 -2816 0 1.000000 -2817 0 1.000000 -2818 0 1.000000 -2819 0 1.000000 -2820 0 1.000000 -2821 0 1.000000 -2822 0 1.000000 -2823 0 1.000000 -2824 0 1.000000 -2825 0 1.000000 -2826 0 1.000000 -2827 0 1.000000 -2828 0 1.000000 -2829 0 1.000000 -2830 0 1.000000 -2831 0 1.000000 -2832 0 1.000000 -2833 0 1.000000 -2834 0 1.000000 -2835 0 1.000000 -2836 0 1.000000 -End NodalData - -Begin NodalData YIELD_STRESS -1 0 100.000000 -2 0 100.000000 -3 0 100.000000 -4 0 100.000000 -5 0 100.000000 -6 0 100.000000 -7 0 100.000000 -8 0 100.000000 -9 0 100.000000 -10 0 100.000000 -11 0 100.000000 -12 0 100.000000 -13 0 100.000000 -14 0 100.000000 -15 0 100.000000 -16 0 100.000000 -17 0 100.000000 -18 0 100.000000 -19 0 100.000000 -20 0 100.000000 -21 0 100.000000 -22 0 100.000000 -23 0 100.000000 -24 0 100.000000 -25 0 100.000000 -26 0 100.000000 -27 0 100.000000 -28 0 100.000000 -29 0 100.000000 -30 0 100.000000 -31 0 100.000000 -32 0 100.000000 -33 0 100.000000 -34 0 100.000000 -35 0 100.000000 -36 0 100.000000 -37 0 100.000000 -38 0 100.000000 -39 0 100.000000 -40 0 100.000000 -41 0 100.000000 -42 0 100.000000 -43 0 100.000000 -44 0 100.000000 -45 0 100.000000 -46 0 100.000000 -47 0 100.000000 -48 0 100.000000 -49 0 100.000000 -50 0 100.000000 -51 0 100.000000 -52 0 100.000000 -53 0 100.000000 -54 0 100.000000 -55 0 100.000000 -56 0 100.000000 -57 0 100.000000 -58 0 100.000000 -59 0 100.000000 -60 0 100.000000 -61 0 100.000000 -62 0 100.000000 -63 0 100.000000 -64 0 100.000000 -65 0 100.000000 -66 0 100.000000 -67 0 100.000000 -68 0 100.000000 -69 0 100.000000 -70 0 100.000000 -71 0 100.000000 -72 0 100.000000 -73 0 100.000000 -74 0 100.000000 -75 0 100.000000 -76 0 100.000000 -77 0 100.000000 -78 0 100.000000 -79 0 100.000000 -80 0 100.000000 -81 0 100.000000 -82 0 100.000000 -83 0 100.000000 -84 0 100.000000 -85 0 100.000000 -86 0 100.000000 -87 0 100.000000 -88 0 100.000000 -89 0 100.000000 -90 0 100.000000 -91 0 100.000000 -92 0 100.000000 -93 0 100.000000 -94 0 100.000000 -95 0 100.000000 -96 0 100.000000 -97 0 100.000000 -98 0 100.000000 -99 0 100.000000 -100 0 100.000000 -101 0 100.000000 -102 0 100.000000 -103 0 100.000000 -104 0 100.000000 -105 0 100.000000 -106 0 100.000000 -107 0 100.000000 -108 0 100.000000 -109 0 100.000000 -110 0 100.000000 -111 0 100.000000 -112 0 100.000000 -113 0 100.000000 -114 0 100.000000 -115 0 100.000000 -116 0 100.000000 -117 0 100.000000 -118 0 100.000000 -119 0 100.000000 -120 0 100.000000 -121 0 100.000000 -122 0 100.000000 -123 0 100.000000 -124 0 100.000000 -125 0 100.000000 -126 0 100.000000 -127 0 100.000000 -128 0 100.000000 -129 0 100.000000 -130 0 100.000000 -131 0 100.000000 -132 0 100.000000 -133 0 100.000000 -134 0 100.000000 -135 0 100.000000 -136 0 100.000000 -137 0 100.000000 -138 0 100.000000 -139 0 100.000000 -140 0 100.000000 -141 0 100.000000 -142 0 100.000000 -143 0 100.000000 -144 0 100.000000 -145 0 100.000000 -146 0 100.000000 -147 0 100.000000 -148 0 100.000000 -149 0 100.000000 -150 0 100.000000 -151 0 100.000000 -152 0 100.000000 -153 0 100.000000 -154 0 100.000000 -155 0 100.000000 -156 0 100.000000 -157 0 100.000000 -158 0 100.000000 -159 0 100.000000 -160 0 100.000000 -161 0 100.000000 -162 0 100.000000 -163 0 100.000000 -164 0 100.000000 -165 0 100.000000 -166 0 100.000000 -167 0 100.000000 -168 0 100.000000 -169 0 100.000000 -170 0 100.000000 -171 0 100.000000 -172 0 100.000000 -173 0 100.000000 -174 0 100.000000 -175 0 100.000000 -176 0 100.000000 -177 0 100.000000 -178 0 100.000000 -179 0 100.000000 -180 0 100.000000 -181 0 100.000000 -182 0 100.000000 -183 0 100.000000 -184 0 100.000000 -185 0 100.000000 -186 0 100.000000 -187 0 100.000000 -188 0 100.000000 -189 0 100.000000 -190 0 100.000000 -191 0 100.000000 -192 0 100.000000 -193 0 100.000000 -194 0 100.000000 -195 0 100.000000 -196 0 100.000000 -197 0 100.000000 -198 0 100.000000 -199 0 100.000000 -200 0 100.000000 -201 0 100.000000 -202 0 100.000000 -203 0 100.000000 -204 0 100.000000 -205 0 100.000000 -206 0 100.000000 -207 0 100.000000 -208 0 100.000000 -209 0 100.000000 -210 0 100.000000 -211 0 100.000000 -212 0 100.000000 -213 0 100.000000 -214 0 100.000000 -215 0 100.000000 -216 0 100.000000 -217 0 100.000000 -218 0 100.000000 -219 0 100.000000 -220 0 100.000000 -221 0 100.000000 -222 0 100.000000 -223 0 100.000000 -224 0 100.000000 -225 0 100.000000 -226 0 100.000000 -227 0 100.000000 -228 0 100.000000 -229 0 100.000000 -230 0 100.000000 -231 0 100.000000 -232 0 100.000000 -233 0 100.000000 -234 0 100.000000 -235 0 100.000000 -236 0 100.000000 -237 0 100.000000 -238 0 100.000000 -239 0 100.000000 -240 0 100.000000 -241 0 100.000000 -242 0 100.000000 -243 0 100.000000 -244 0 100.000000 -245 0 100.000000 -246 0 100.000000 -247 0 100.000000 -248 0 100.000000 -249 0 100.000000 -250 0 100.000000 -251 0 100.000000 -252 0 100.000000 -253 0 100.000000 -254 0 100.000000 -255 0 100.000000 -256 0 100.000000 -257 0 100.000000 -258 0 100.000000 -259 0 100.000000 -260 0 100.000000 -261 0 100.000000 -262 0 100.000000 -263 0 100.000000 -264 0 100.000000 -265 0 100.000000 -266 0 100.000000 -267 0 100.000000 -268 0 100.000000 -269 0 100.000000 -270 0 100.000000 -271 0 100.000000 -272 0 100.000000 -273 0 100.000000 -274 0 100.000000 -275 0 100.000000 -276 0 100.000000 -277 0 100.000000 -278 0 100.000000 -279 0 100.000000 -280 0 100.000000 -281 0 100.000000 -282 0 100.000000 -283 0 100.000000 -284 0 100.000000 -285 0 100.000000 -286 0 100.000000 -287 0 100.000000 -288 0 100.000000 -289 0 100.000000 -290 0 100.000000 -291 0 100.000000 -292 0 100.000000 -293 0 100.000000 -294 0 100.000000 -295 0 100.000000 -296 0 100.000000 -297 0 100.000000 -298 0 100.000000 -299 0 100.000000 -300 0 100.000000 -301 0 100.000000 -302 0 100.000000 -303 0 100.000000 -304 0 100.000000 -305 0 100.000000 -306 0 100.000000 -307 0 100.000000 -308 0 100.000000 -309 0 100.000000 -310 0 100.000000 -311 0 100.000000 -312 0 100.000000 -313 0 100.000000 -314 0 100.000000 -315 0 100.000000 -316 0 100.000000 -317 0 100.000000 -318 0 100.000000 -319 0 100.000000 -320 0 100.000000 -321 0 100.000000 -322 0 100.000000 -323 0 100.000000 -324 0 100.000000 -325 0 100.000000 -326 0 100.000000 -327 0 100.000000 -328 0 100.000000 -329 0 100.000000 -330 0 100.000000 -331 0 100.000000 -332 0 100.000000 -333 0 100.000000 -334 0 100.000000 -335 0 100.000000 -336 0 100.000000 -337 0 100.000000 -338 0 100.000000 -339 0 100.000000 -340 0 100.000000 -341 0 100.000000 -342 0 100.000000 -343 0 100.000000 -344 0 100.000000 -345 0 100.000000 -346 0 100.000000 -347 0 100.000000 -348 0 100.000000 -349 0 100.000000 -350 0 100.000000 -351 0 100.000000 -352 0 100.000000 -353 0 100.000000 -354 0 100.000000 -355 0 100.000000 -356 0 100.000000 -357 0 100.000000 -358 0 100.000000 -359 0 100.000000 -360 0 100.000000 -361 0 100.000000 -362 0 100.000000 -363 0 100.000000 -364 0 100.000000 -365 0 100.000000 -366 0 100.000000 -367 0 100.000000 -368 0 100.000000 -369 0 100.000000 -370 0 100.000000 -371 0 100.000000 -372 0 100.000000 -373 0 100.000000 -374 0 100.000000 -375 0 100.000000 -376 0 100.000000 -377 0 100.000000 -378 0 100.000000 -379 0 100.000000 -380 0 100.000000 -381 0 100.000000 -382 0 100.000000 -383 0 100.000000 -384 0 100.000000 -385 0 100.000000 -386 0 100.000000 -387 0 100.000000 -388 0 100.000000 -389 0 100.000000 -390 0 100.000000 -391 0 100.000000 -392 0 100.000000 -393 0 100.000000 -394 0 100.000000 -395 0 100.000000 -396 0 100.000000 -397 0 100.000000 -398 0 100.000000 -399 0 100.000000 -400 0 100.000000 -401 0 100.000000 -402 0 100.000000 -403 0 100.000000 -404 0 100.000000 -405 0 100.000000 -406 0 100.000000 -407 0 100.000000 -408 0 100.000000 -409 0 100.000000 -410 0 100.000000 -411 0 100.000000 -412 0 100.000000 -413 0 100.000000 -414 0 100.000000 -415 0 100.000000 -416 0 100.000000 -417 0 100.000000 -418 0 100.000000 -419 0 100.000000 -420 0 100.000000 -421 0 100.000000 -422 0 100.000000 -423 0 100.000000 -424 0 100.000000 -425 0 100.000000 -426 0 100.000000 -427 0 100.000000 -428 0 100.000000 -429 0 100.000000 -430 0 100.000000 -431 0 100.000000 -432 0 100.000000 -433 0 100.000000 -434 0 100.000000 -435 0 100.000000 -436 0 100.000000 -437 0 100.000000 -438 0 100.000000 -439 0 100.000000 -440 0 100.000000 -441 0 100.000000 -442 0 100.000000 -443 0 100.000000 -444 0 100.000000 -445 0 100.000000 -446 0 100.000000 -447 0 100.000000 -448 0 100.000000 -449 0 100.000000 -450 0 100.000000 -451 0 100.000000 -452 0 100.000000 -453 0 100.000000 -454 0 100.000000 -455 0 100.000000 -456 0 100.000000 -457 0 100.000000 -458 0 100.000000 -459 0 100.000000 -460 0 100.000000 -461 0 100.000000 -462 0 100.000000 -463 0 100.000000 -464 0 100.000000 -465 0 100.000000 -466 0 100.000000 -467 0 100.000000 -468 0 100.000000 -469 0 100.000000 -470 0 100.000000 -471 0 100.000000 -472 0 100.000000 -473 0 100.000000 -474 0 100.000000 -475 0 100.000000 -476 0 100.000000 -477 0 100.000000 -478 0 100.000000 -479 0 100.000000 -480 0 100.000000 -481 0 100.000000 -482 0 100.000000 -483 0 100.000000 -484 0 100.000000 -485 0 100.000000 -486 0 100.000000 -487 0 100.000000 -488 0 100.000000 -489 0 100.000000 -490 0 100.000000 -491 0 100.000000 -492 0 100.000000 -493 0 100.000000 -494 0 100.000000 -495 0 100.000000 -496 0 100.000000 -497 0 100.000000 -498 0 100.000000 -499 0 100.000000 -500 0 100.000000 -501 0 100.000000 -502 0 100.000000 -503 0 100.000000 -504 0 100.000000 -505 0 100.000000 -506 0 100.000000 -507 0 100.000000 -508 0 100.000000 -509 0 100.000000 -510 0 100.000000 -511 0 100.000000 -512 0 100.000000 -513 0 100.000000 -514 0 100.000000 -515 0 100.000000 -516 0 100.000000 -517 0 100.000000 -518 0 100.000000 -519 0 100.000000 -520 0 100.000000 -521 0 100.000000 -522 0 100.000000 -523 0 100.000000 -524 0 100.000000 -525 0 100.000000 -526 0 100.000000 -527 0 100.000000 -528 0 100.000000 -529 0 100.000000 -530 0 100.000000 -531 0 100.000000 -532 0 100.000000 -533 0 100.000000 -534 0 100.000000 -535 0 100.000000 -536 0 100.000000 -537 0 100.000000 -538 0 100.000000 -539 0 100.000000 -540 0 100.000000 -541 0 100.000000 -542 0 100.000000 -543 0 100.000000 -544 0 100.000000 -545 0 100.000000 -546 0 100.000000 -547 0 100.000000 -548 0 100.000000 -549 0 100.000000 -550 0 100.000000 -551 0 100.000000 -552 0 100.000000 -553 0 100.000000 -554 0 100.000000 -555 0 100.000000 -556 0 100.000000 -557 0 100.000000 -558 0 100.000000 -559 0 100.000000 -560 0 100.000000 -561 0 100.000000 -562 0 100.000000 -563 0 100.000000 -564 0 100.000000 -565 0 100.000000 -566 0 100.000000 -567 0 100.000000 -568 0 100.000000 -569 0 100.000000 -570 0 100.000000 -571 0 100.000000 -572 0 100.000000 -573 0 100.000000 -574 0 100.000000 -575 0 100.000000 -576 0 100.000000 -577 0 100.000000 -578 0 100.000000 -579 0 100.000000 -580 0 100.000000 -581 0 100.000000 -582 0 100.000000 -583 0 100.000000 -584 0 100.000000 -585 0 100.000000 -586 0 100.000000 -587 0 100.000000 -588 0 100.000000 -589 0 100.000000 -590 0 100.000000 -591 0 100.000000 -592 0 100.000000 -593 0 100.000000 -594 0 100.000000 -595 0 100.000000 -596 0 100.000000 -597 0 100.000000 -598 0 100.000000 -599 0 100.000000 -600 0 100.000000 -601 0 100.000000 -602 0 100.000000 -603 0 100.000000 -604 0 100.000000 -605 0 100.000000 -606 0 100.000000 -607 0 100.000000 -608 0 100.000000 -609 0 100.000000 -610 0 100.000000 -611 0 100.000000 -612 0 100.000000 -613 0 100.000000 -614 0 100.000000 -615 0 100.000000 -616 0 100.000000 -617 0 100.000000 -618 0 100.000000 -619 0 100.000000 -620 0 100.000000 -621 0 100.000000 -622 0 100.000000 -623 0 100.000000 -624 0 100.000000 -625 0 100.000000 -626 0 100.000000 -627 0 100.000000 -628 0 100.000000 -629 0 100.000000 -630 0 100.000000 -631 0 100.000000 -632 0 100.000000 -633 0 100.000000 -634 0 100.000000 -635 0 100.000000 -636 0 100.000000 -637 0 100.000000 -638 0 100.000000 -639 0 100.000000 -640 0 100.000000 -641 0 100.000000 -642 0 100.000000 -643 0 100.000000 -644 0 100.000000 -645 0 100.000000 -646 0 100.000000 -647 0 100.000000 -648 0 100.000000 -649 0 100.000000 -650 0 100.000000 -651 0 100.000000 -652 0 100.000000 -653 0 100.000000 -654 0 100.000000 -655 0 100.000000 -656 0 100.000000 -657 0 100.000000 -658 0 100.000000 -659 0 100.000000 -660 0 100.000000 -661 0 100.000000 -662 0 100.000000 -663 0 100.000000 -664 0 100.000000 -665 0 100.000000 -666 0 100.000000 -667 0 100.000000 -668 0 100.000000 -669 0 100.000000 -670 0 100.000000 -671 0 100.000000 -672 0 100.000000 -673 0 100.000000 -674 0 100.000000 -675 0 100.000000 -676 0 100.000000 -677 0 100.000000 -678 0 100.000000 -679 0 100.000000 -680 0 100.000000 -681 0 100.000000 -682 0 100.000000 -683 0 100.000000 -684 0 100.000000 -685 0 100.000000 -686 0 100.000000 -687 0 100.000000 -688 0 100.000000 -689 0 100.000000 -690 0 100.000000 -691 0 100.000000 -692 0 100.000000 -693 0 100.000000 -694 0 100.000000 -695 0 100.000000 -696 0 100.000000 -697 0 100.000000 -698 0 100.000000 -699 0 100.000000 -700 0 100.000000 -701 0 100.000000 -702 0 100.000000 -703 0 100.000000 -704 0 100.000000 -705 0 100.000000 -706 0 100.000000 -707 0 100.000000 -708 0 100.000000 -709 0 100.000000 -710 0 100.000000 -711 0 100.000000 -712 0 100.000000 -713 0 100.000000 -714 0 100.000000 -715 0 100.000000 -716 0 100.000000 -717 0 100.000000 -718 0 100.000000 -719 0 100.000000 -720 0 100.000000 -721 0 100.000000 -722 0 100.000000 -723 0 100.000000 -724 0 100.000000 -725 0 100.000000 -726 0 100.000000 -727 0 100.000000 -728 0 100.000000 -729 0 100.000000 -730 0 100.000000 -731 0 100.000000 -732 0 100.000000 -733 0 100.000000 -734 0 100.000000 -735 0 100.000000 -736 0 100.000000 -737 0 100.000000 -738 0 100.000000 -739 0 100.000000 -740 0 100.000000 -741 0 100.000000 -742 0 100.000000 -743 0 100.000000 -744 0 100.000000 -745 0 100.000000 -746 0 100.000000 -747 0 100.000000 -748 0 100.000000 -749 0 100.000000 -750 0 100.000000 -751 0 100.000000 -752 0 100.000000 -753 0 100.000000 -754 0 100.000000 -755 0 100.000000 -756 0 100.000000 -757 0 100.000000 -758 0 100.000000 -759 0 100.000000 -760 0 100.000000 -761 0 100.000000 -762 0 100.000000 -763 0 100.000000 -764 0 100.000000 -765 0 100.000000 -766 0 100.000000 -767 0 100.000000 -768 0 100.000000 -769 0 100.000000 -770 0 100.000000 -771 0 100.000000 -772 0 100.000000 -773 0 100.000000 -774 0 100.000000 -775 0 100.000000 -776 0 100.000000 -777 0 100.000000 -778 0 100.000000 -779 0 100.000000 -780 0 100.000000 -781 0 100.000000 -782 0 100.000000 -783 0 100.000000 -784 0 100.000000 -785 0 100.000000 -786 0 100.000000 -787 0 100.000000 -788 0 100.000000 -789 0 100.000000 -790 0 100.000000 -791 0 100.000000 -792 0 100.000000 -793 0 100.000000 -794 0 100.000000 -795 0 100.000000 -796 0 100.000000 -797 0 100.000000 -798 0 100.000000 -799 0 100.000000 -800 0 100.000000 -801 0 100.000000 -802 0 100.000000 -803 0 100.000000 -804 0 100.000000 -805 0 100.000000 -806 0 100.000000 -807 0 100.000000 -808 0 100.000000 -809 0 100.000000 -810 0 100.000000 -811 0 100.000000 -812 0 100.000000 -813 0 100.000000 -814 0 100.000000 -815 0 100.000000 -816 0 100.000000 -817 0 100.000000 -818 0 100.000000 -819 0 100.000000 -820 0 100.000000 -821 0 100.000000 -822 0 100.000000 -823 0 100.000000 -824 0 100.000000 -825 0 100.000000 -826 0 100.000000 -827 0 100.000000 -828 0 100.000000 -829 0 100.000000 -830 0 100.000000 -831 0 100.000000 -832 0 100.000000 -833 0 100.000000 -834 0 100.000000 -835 0 100.000000 -836 0 100.000000 -837 0 100.000000 -838 0 100.000000 -839 0 100.000000 -840 0 100.000000 -841 0 100.000000 -842 0 100.000000 -843 0 100.000000 -844 0 100.000000 -845 0 100.000000 -846 0 100.000000 -847 0 100.000000 -848 0 100.000000 -849 0 100.000000 -850 0 100.000000 -851 0 100.000000 -852 0 100.000000 -853 0 100.000000 -854 0 100.000000 -855 0 100.000000 -856 0 100.000000 -857 0 100.000000 -858 0 100.000000 -859 0 100.000000 -860 0 100.000000 -861 0 100.000000 -862 0 100.000000 -863 0 100.000000 -864 0 100.000000 -865 0 100.000000 -866 0 100.000000 -867 0 100.000000 -868 0 100.000000 -869 0 100.000000 -870 0 100.000000 -871 0 100.000000 -872 0 100.000000 -873 0 100.000000 -874 0 100.000000 -875 0 100.000000 -876 0 100.000000 -877 0 100.000000 -878 0 100.000000 -879 0 100.000000 -880 0 100.000000 -881 0 100.000000 -882 0 100.000000 -883 0 100.000000 -884 0 100.000000 -885 0 100.000000 -886 0 100.000000 -887 0 100.000000 -888 0 100.000000 -889 0 100.000000 -890 0 100.000000 -891 0 100.000000 -892 0 100.000000 -893 0 100.000000 -894 0 100.000000 -895 0 100.000000 -896 0 100.000000 -897 0 100.000000 -898 0 100.000000 -899 0 100.000000 -900 0 100.000000 -901 0 100.000000 -902 0 100.000000 -903 0 100.000000 -904 0 100.000000 -905 0 100.000000 -906 0 100.000000 -907 0 100.000000 -908 0 100.000000 -909 0 100.000000 -910 0 100.000000 -911 0 100.000000 -912 0 100.000000 -913 0 100.000000 -914 0 100.000000 -915 0 100.000000 -916 0 100.000000 -917 0 100.000000 -918 0 100.000000 -919 0 100.000000 -920 0 100.000000 -921 0 100.000000 -922 0 100.000000 -923 0 100.000000 -924 0 100.000000 -925 0 100.000000 -926 0 100.000000 -927 0 100.000000 -928 0 100.000000 -929 0 100.000000 -930 0 100.000000 -931 0 100.000000 -932 0 100.000000 -933 0 100.000000 -934 0 100.000000 -935 0 100.000000 -936 0 100.000000 -937 0 100.000000 -938 0 100.000000 -939 0 100.000000 -940 0 100.000000 -941 0 100.000000 -942 0 100.000000 -943 0 100.000000 -944 0 100.000000 -945 0 100.000000 -946 0 100.000000 -947 0 100.000000 -948 0 100.000000 -949 0 100.000000 -950 0 100.000000 -951 0 100.000000 -952 0 100.000000 -953 0 100.000000 -954 0 100.000000 -955 0 100.000000 -956 0 100.000000 -957 0 100.000000 -958 0 100.000000 -959 0 100.000000 -960 0 100.000000 -961 0 100.000000 -962 0 100.000000 -963 0 100.000000 -964 0 100.000000 -965 0 100.000000 -966 0 100.000000 -967 0 100.000000 -968 0 100.000000 -969 0 100.000000 -970 0 100.000000 -971 0 100.000000 -972 0 100.000000 -973 0 100.000000 -974 0 100.000000 -975 0 100.000000 -976 0 100.000000 -977 0 100.000000 -978 0 100.000000 -979 0 100.000000 -980 0 100.000000 -981 0 100.000000 -982 0 100.000000 -983 0 100.000000 -984 0 100.000000 -985 0 100.000000 -986 0 100.000000 -987 0 100.000000 -988 0 100.000000 -989 0 100.000000 -990 0 100.000000 -991 0 100.000000 -992 0 100.000000 -993 0 100.000000 -994 0 100.000000 -995 0 100.000000 -996 0 100.000000 -997 0 100.000000 -998 0 100.000000 -999 0 100.000000 -1000 0 100.000000 -1001 0 100.000000 -1002 0 100.000000 -1003 0 100.000000 -1004 0 100.000000 -1005 0 100.000000 -1006 0 100.000000 -1007 0 100.000000 -1008 0 100.000000 -1009 0 100.000000 -1010 0 100.000000 -1011 0 100.000000 -1012 0 100.000000 -1013 0 100.000000 -1014 0 100.000000 -1015 0 100.000000 -1016 0 100.000000 -1017 0 100.000000 -1018 0 100.000000 -1019 0 100.000000 -1020 0 100.000000 -1021 0 100.000000 -1022 0 100.000000 -1023 0 100.000000 -1024 0 100.000000 -1025 0 100.000000 -1026 0 100.000000 -1027 0 100.000000 -1028 0 100.000000 -1029 0 100.000000 -1030 0 100.000000 -1031 0 100.000000 -1032 0 100.000000 -1033 0 100.000000 -1034 0 100.000000 -1035 0 100.000000 -1036 0 100.000000 -1037 0 100.000000 -1038 0 100.000000 -1039 0 100.000000 -1040 0 100.000000 -1041 0 100.000000 -1042 0 100.000000 -1043 0 100.000000 -1044 0 100.000000 -1045 0 100.000000 -1046 0 100.000000 -1047 0 100.000000 -1048 0 100.000000 -1049 0 100.000000 -1050 0 100.000000 -1051 0 100.000000 -1052 0 100.000000 -1053 0 100.000000 -1054 0 100.000000 -1055 0 100.000000 -1056 0 100.000000 -1057 0 100.000000 -1058 0 100.000000 -1059 0 100.000000 -1060 0 100.000000 -1061 0 100.000000 -1062 0 100.000000 -1063 0 100.000000 -1064 0 100.000000 -1065 0 100.000000 -1066 0 100.000000 -1067 0 100.000000 -1068 0 100.000000 -1069 0 100.000000 -1070 0 100.000000 -1071 0 100.000000 -1072 0 100.000000 -1073 0 100.000000 -1074 0 100.000000 -1075 0 100.000000 -1076 0 100.000000 -1077 0 100.000000 -1078 0 100.000000 -1079 0 100.000000 -1080 0 100.000000 -1081 0 100.000000 -1082 0 100.000000 -1083 0 100.000000 -1084 0 100.000000 -1085 0 100.000000 -1086 0 100.000000 -1087 0 100.000000 -1088 0 100.000000 -1089 0 100.000000 -1090 0 100.000000 -1091 0 100.000000 -1092 0 100.000000 -1093 0 100.000000 -1094 0 100.000000 -1095 0 100.000000 -1096 0 100.000000 -1097 0 100.000000 -1098 0 100.000000 -1099 0 100.000000 -1100 0 100.000000 -1101 0 100.000000 -1102 0 100.000000 -1103 0 100.000000 -1104 0 100.000000 -1105 0 100.000000 -1106 0 100.000000 -1107 0 100.000000 -1108 0 100.000000 -1109 0 100.000000 -1110 0 100.000000 -1111 0 100.000000 -1112 0 100.000000 -1113 0 100.000000 -1114 0 100.000000 -1115 0 100.000000 -1116 0 100.000000 -1117 0 100.000000 -1118 0 100.000000 -1119 0 100.000000 -1120 0 100.000000 -1121 0 100.000000 -1122 0 100.000000 -1123 0 100.000000 -1124 0 100.000000 -1125 0 100.000000 -1126 0 100.000000 -1127 0 100.000000 -1128 0 100.000000 -1129 0 100.000000 -1130 0 100.000000 -1131 0 100.000000 -1132 0 100.000000 -1133 0 100.000000 -1134 0 100.000000 -1135 0 100.000000 -1136 0 100.000000 -1137 0 100.000000 -1138 0 100.000000 -1139 0 100.000000 -1140 0 100.000000 -1141 0 100.000000 -1142 0 100.000000 -1143 0 100.000000 -1144 0 100.000000 -1145 0 100.000000 -1146 0 100.000000 -1147 0 100.000000 -1148 0 100.000000 -1149 0 100.000000 -1150 0 100.000000 -1151 0 100.000000 -1152 0 100.000000 -1153 0 100.000000 -1154 0 100.000000 -1155 0 100.000000 -1156 0 100.000000 -1157 0 100.000000 -1158 0 100.000000 -1159 0 100.000000 -1160 0 100.000000 -1161 0 100.000000 -1162 0 100.000000 -1163 0 100.000000 -1164 0 100.000000 -1165 0 100.000000 -1166 0 100.000000 -1167 0 100.000000 -1168 0 100.000000 -1169 0 100.000000 -1170 0 100.000000 -1171 0 100.000000 -1172 0 100.000000 -1173 0 100.000000 -1174 0 100.000000 -1175 0 100.000000 -1176 0 100.000000 -1177 0 100.000000 -1178 0 100.000000 -1179 0 100.000000 -1180 0 100.000000 -1181 0 100.000000 -1182 0 100.000000 -1183 0 100.000000 -1184 0 100.000000 -1185 0 100.000000 -1186 0 100.000000 -1187 0 100.000000 -1188 0 100.000000 -1189 0 100.000000 -1190 0 100.000000 -1191 0 100.000000 -1192 0 100.000000 -1193 0 100.000000 -1194 0 100.000000 -1195 0 100.000000 -1196 0 100.000000 -1197 0 100.000000 -1198 0 100.000000 -1199 0 100.000000 -1200 0 100.000000 -1201 0 100.000000 -1202 0 100.000000 -1203 0 100.000000 -1204 0 100.000000 -1205 0 100.000000 -1206 0 100.000000 -1207 0 100.000000 -1208 0 100.000000 -1209 0 100.000000 -1210 0 100.000000 -1211 0 100.000000 -1212 0 100.000000 -1213 0 100.000000 -1214 0 100.000000 -1215 0 100.000000 -1216 0 100.000000 -1217 0 100.000000 -1218 0 100.000000 -1219 0 100.000000 -1220 0 100.000000 -1221 0 100.000000 -1222 0 100.000000 -1223 0 100.000000 -1224 0 100.000000 -1225 0 100.000000 -1226 0 100.000000 -1227 0 100.000000 -1228 0 100.000000 -1229 0 100.000000 -1230 0 100.000000 -1231 0 100.000000 -1232 0 100.000000 -1233 0 100.000000 -1234 0 100.000000 -1235 0 100.000000 -1236 0 100.000000 -1237 0 100.000000 -1238 0 100.000000 -1239 0 100.000000 -1240 0 100.000000 -1241 0 100.000000 -1242 0 100.000000 -1243 0 100.000000 -1244 0 100.000000 -1245 0 100.000000 -1246 0 100.000000 -1247 0 100.000000 -1248 0 100.000000 -1249 0 100.000000 -1250 0 100.000000 -1251 0 100.000000 -1252 0 100.000000 -1253 0 100.000000 -1254 0 100.000000 -1255 0 100.000000 -1256 0 100.000000 -1257 0 100.000000 -1258 0 100.000000 -1259 0 100.000000 -1260 0 100.000000 -1261 0 100.000000 -1262 0 100.000000 -1263 0 100.000000 -1264 0 100.000000 -1265 0 100.000000 -1266 0 100.000000 -1267 0 100.000000 -1268 0 100.000000 -1269 0 100.000000 -1270 0 100.000000 -1271 0 100.000000 -1272 0 100.000000 -1273 0 100.000000 -1274 0 100.000000 -1275 0 100.000000 -1276 0 100.000000 -1277 0 100.000000 -1278 0 100.000000 -1279 0 100.000000 -1280 0 100.000000 -1281 0 100.000000 -1282 0 100.000000 -1283 0 100.000000 -1284 0 100.000000 -1285 0 100.000000 -1286 0 100.000000 -1287 0 100.000000 -1288 0 100.000000 -1289 0 100.000000 -1290 0 100.000000 -1291 0 100.000000 -1292 0 100.000000 -1293 0 100.000000 -1294 0 100.000000 -1295 0 100.000000 -1296 0 100.000000 -1297 0 100.000000 -1298 0 100.000000 -1299 0 100.000000 -1300 0 100.000000 -1301 0 100.000000 -1302 0 100.000000 -1303 0 100.000000 -1304 0 100.000000 -1305 0 100.000000 -1306 0 100.000000 -1307 0 100.000000 -1308 0 100.000000 -1309 0 100.000000 -1310 0 100.000000 -1311 0 100.000000 -1312 0 100.000000 -1313 0 100.000000 -1314 0 100.000000 -1315 0 100.000000 -1316 0 100.000000 -1317 0 100.000000 -1318 0 100.000000 -1319 0 100.000000 -1320 0 100.000000 -1321 0 100.000000 -1322 0 100.000000 -1323 0 100.000000 -1324 0 100.000000 -1325 0 100.000000 -1326 0 100.000000 -1327 0 100.000000 -1328 0 100.000000 -1329 0 100.000000 -1330 0 100.000000 -1331 0 100.000000 -1332 0 100.000000 -1333 0 100.000000 -1334 0 100.000000 -1335 0 100.000000 -1336 0 100.000000 -1337 0 100.000000 -1338 0 100.000000 -1339 0 100.000000 -1340 0 100.000000 -1341 0 100.000000 -1342 0 100.000000 -1343 0 100.000000 -1344 0 100.000000 -1345 0 100.000000 -1346 0 100.000000 -1347 0 100.000000 -1348 0 100.000000 -1349 0 100.000000 -1350 0 100.000000 -1351 0 100.000000 -1352 0 100.000000 -1353 0 100.000000 -1354 0 100.000000 -1355 0 100.000000 -1356 0 100.000000 -1357 0 100.000000 -1358 0 100.000000 -1359 0 100.000000 -1360 0 100.000000 -1361 0 100.000000 -1362 0 100.000000 -1363 0 100.000000 -1364 0 100.000000 -1365 0 100.000000 -1366 0 100.000000 -1367 0 100.000000 -1368 0 100.000000 -1369 0 100.000000 -1370 0 100.000000 -1371 0 100.000000 -1372 0 100.000000 -1373 0 100.000000 -1374 0 100.000000 -1375 0 100.000000 -1376 0 100.000000 -1377 0 100.000000 -1378 0 100.000000 -1379 0 100.000000 -1380 0 100.000000 -1381 0 100.000000 -1382 0 100.000000 -1383 0 100.000000 -1384 0 100.000000 -1385 0 100.000000 -1386 0 100.000000 -1387 0 100.000000 -1388 0 100.000000 -1389 0 100.000000 -1390 0 100.000000 -1391 0 100.000000 -1392 0 100.000000 -1393 0 100.000000 -1394 0 100.000000 -1395 0 100.000000 -1396 0 100.000000 -1397 0 100.000000 -1398 0 100.000000 -1399 0 100.000000 -1400 0 100.000000 -1401 0 100.000000 -1402 0 100.000000 -1403 0 100.000000 -1404 0 100.000000 -1405 0 100.000000 -1406 0 100.000000 -1407 0 100.000000 -1408 0 100.000000 -1409 0 100.000000 -1410 0 100.000000 -1411 0 100.000000 -1412 0 100.000000 -1413 0 100.000000 -1414 0 100.000000 -1415 0 100.000000 -1416 0 100.000000 -1417 0 100.000000 -1418 0 100.000000 -1419 0 100.000000 -1420 0 100.000000 -1421 0 100.000000 -1422 0 100.000000 -1423 0 100.000000 -1424 0 100.000000 -1425 0 100.000000 -1426 0 100.000000 -1427 0 100.000000 -1428 0 100.000000 -1429 0 100.000000 -1430 0 100.000000 -1431 0 100.000000 -1432 0 100.000000 -1433 0 100.000000 -1434 0 100.000000 -1435 0 100.000000 -1436 0 100.000000 -1437 0 100.000000 -1438 0 100.000000 -1439 0 100.000000 -1440 0 100.000000 -1441 0 100.000000 -1442 0 100.000000 -1443 0 100.000000 -1444 0 100.000000 -1445 0 100.000000 -1446 0 100.000000 -1447 0 100.000000 -1448 0 100.000000 -1449 0 100.000000 -1450 0 100.000000 -1451 0 100.000000 -1452 0 100.000000 -1453 0 100.000000 -1454 0 100.000000 -1455 0 100.000000 -1456 0 100.000000 -1457 0 100.000000 -1458 0 100.000000 -1459 0 100.000000 -1460 0 100.000000 -1461 0 100.000000 -1462 0 100.000000 -1463 0 100.000000 -1464 0 100.000000 -1465 0 100.000000 -1466 0 100.000000 -1467 0 100.000000 -1468 0 100.000000 -1469 0 100.000000 -1470 0 100.000000 -1471 0 100.000000 -1472 0 100.000000 -1473 0 100.000000 -1474 0 100.000000 -1475 0 100.000000 -1476 0 100.000000 -1477 0 100.000000 -1478 0 100.000000 -1479 0 100.000000 -1480 0 100.000000 -1481 0 100.000000 -1482 0 100.000000 -1483 0 100.000000 -1484 0 100.000000 -1485 0 100.000000 -1486 0 100.000000 -1487 0 100.000000 -1488 0 100.000000 -1489 0 100.000000 -1490 0 100.000000 -1491 0 100.000000 -1492 0 100.000000 -1493 0 100.000000 -1494 0 100.000000 -1495 0 100.000000 -1496 0 100.000000 -1497 0 100.000000 -1498 0 100.000000 -1499 0 100.000000 -1500 0 100.000000 -1501 0 100.000000 -1502 0 100.000000 -1503 0 100.000000 -1504 0 100.000000 -1505 0 100.000000 -1506 0 100.000000 -1507 0 100.000000 -1508 0 100.000000 -1509 0 100.000000 -1510 0 100.000000 -1511 0 100.000000 -1512 0 100.000000 -1513 0 100.000000 -1514 0 100.000000 -1515 0 100.000000 -1516 0 100.000000 -1517 0 100.000000 -1518 0 100.000000 -1519 0 100.000000 -1520 0 100.000000 -1521 0 100.000000 -1522 0 100.000000 -1523 0 100.000000 -1524 0 100.000000 -1525 0 100.000000 -1526 0 100.000000 -1527 0 100.000000 -1528 0 100.000000 -1529 0 100.000000 -1530 0 100.000000 -1531 0 100.000000 -1532 0 100.000000 -1533 0 100.000000 -1534 0 100.000000 -1535 0 100.000000 -1536 0 100.000000 -1537 0 100.000000 -1538 0 100.000000 -1539 0 100.000000 -1540 0 100.000000 -1541 0 100.000000 -1542 0 100.000000 -1543 0 100.000000 -1544 0 100.000000 -1545 0 100.000000 -1546 0 100.000000 -1547 0 100.000000 -1548 0 100.000000 -1549 0 100.000000 -1550 0 100.000000 -1551 0 100.000000 -1552 0 100.000000 -1553 0 100.000000 -1554 0 100.000000 -1555 0 100.000000 -1556 0 100.000000 -1557 0 100.000000 -1558 0 100.000000 -1559 0 100.000000 -1560 0 100.000000 -1561 0 100.000000 -1562 0 100.000000 -1563 0 100.000000 -1564 0 100.000000 -1565 0 100.000000 -1566 0 100.000000 -1567 0 100.000000 -1568 0 100.000000 -1569 0 100.000000 -1570 0 100.000000 -1571 0 100.000000 -1572 0 100.000000 -1573 0 100.000000 -1574 0 100.000000 -1575 0 100.000000 -1576 0 100.000000 -1577 0 100.000000 -1578 0 100.000000 -1579 0 100.000000 -1580 0 100.000000 -1581 0 100.000000 -1582 0 100.000000 -1583 0 100.000000 -1584 0 100.000000 -1585 0 100.000000 -1586 0 100.000000 -1587 0 100.000000 -1588 0 100.000000 -1589 0 100.000000 -1590 0 100.000000 -1591 0 100.000000 -1592 0 100.000000 -1593 0 100.000000 -1594 0 100.000000 -1595 0 100.000000 -1596 0 100.000000 -1597 0 100.000000 -1598 0 100.000000 -1599 0 100.000000 -1600 0 100.000000 -1601 0 100.000000 -1602 0 100.000000 -1603 0 100.000000 -1604 0 100.000000 -1605 0 100.000000 -1606 0 100.000000 -1607 0 100.000000 -1608 0 100.000000 -1609 0 100.000000 -1610 0 100.000000 -1611 0 100.000000 -1612 0 100.000000 -1613 0 100.000000 -1614 0 100.000000 -1615 0 100.000000 -1616 0 100.000000 -1617 0 100.000000 -1618 0 100.000000 -1619 0 100.000000 -1620 0 100.000000 -1621 0 100.000000 -1622 0 100.000000 -1623 0 100.000000 -1624 0 100.000000 -1625 0 100.000000 -1626 0 100.000000 -1627 0 100.000000 -1628 0 100.000000 -1629 0 100.000000 -1630 0 100.000000 -1631 0 100.000000 -1632 0 100.000000 -1633 0 100.000000 -1634 0 100.000000 -1635 0 100.000000 -1636 0 100.000000 -1637 0 100.000000 -1638 0 100.000000 -1639 0 100.000000 -1640 0 100.000000 -1641 0 100.000000 -1642 0 100.000000 -1643 0 100.000000 -1644 0 100.000000 -1645 0 100.000000 -1646 0 100.000000 -1647 0 100.000000 -1648 0 100.000000 -1649 0 100.000000 -1650 0 100.000000 -1651 0 100.000000 -1652 0 100.000000 -1653 0 100.000000 -1654 0 100.000000 -1655 0 100.000000 -1656 0 100.000000 -1657 0 100.000000 -1658 0 100.000000 -1659 0 100.000000 -1660 0 100.000000 -1661 0 100.000000 -1662 0 100.000000 -1663 0 100.000000 -1664 0 100.000000 -1665 0 100.000000 -1666 0 100.000000 -1667 0 100.000000 -1668 0 100.000000 -1669 0 100.000000 -1670 0 100.000000 -1671 0 100.000000 -1672 0 100.000000 -1673 0 100.000000 -1674 0 100.000000 -1675 0 100.000000 -1676 0 100.000000 -1677 0 100.000000 -1678 0 100.000000 -1679 0 100.000000 -1680 0 100.000000 -1681 0 100.000000 -1682 0 100.000000 -1683 0 100.000000 -1684 0 100.000000 -1685 0 100.000000 -1686 0 100.000000 -1687 0 100.000000 -1688 0 100.000000 -1689 0 100.000000 -1690 0 100.000000 -1691 0 100.000000 -1692 0 100.000000 -1693 0 100.000000 -1694 0 100.000000 -1695 0 100.000000 -1696 0 100.000000 -1697 0 100.000000 -1698 0 100.000000 -1699 0 100.000000 -1700 0 100.000000 -1701 0 100.000000 -1702 0 100.000000 -1703 0 100.000000 -1704 0 100.000000 -1705 0 100.000000 -1706 0 100.000000 -1707 0 100.000000 -1708 0 100.000000 -1709 0 100.000000 -1710 0 100.000000 -1711 0 100.000000 -1712 0 100.000000 -1713 0 100.000000 -1714 0 100.000000 -1715 0 100.000000 -1716 0 100.000000 -1717 0 100.000000 -1718 0 100.000000 -1719 0 100.000000 -1720 0 100.000000 -1721 0 100.000000 -1722 0 100.000000 -1723 0 100.000000 -1724 0 100.000000 -1725 0 100.000000 -1726 0 100.000000 -1727 0 100.000000 -1728 0 100.000000 -1729 0 100.000000 -1730 0 100.000000 -1731 0 100.000000 -1732 0 100.000000 -1733 0 100.000000 -1734 0 100.000000 -1735 0 100.000000 -1736 0 100.000000 -1737 0 100.000000 -1738 0 100.000000 -1739 0 100.000000 -1740 0 100.000000 -1741 0 100.000000 -1742 0 100.000000 -1743 0 100.000000 -1744 0 100.000000 -1745 0 100.000000 -1746 0 100.000000 -1747 0 100.000000 -1748 0 100.000000 -1749 0 100.000000 -1750 0 100.000000 -1751 0 100.000000 -1752 0 100.000000 -1753 0 100.000000 -1754 0 100.000000 -1755 0 100.000000 -1756 0 100.000000 -1757 0 100.000000 -1758 0 100.000000 -1759 0 100.000000 -1760 0 100.000000 -1761 0 100.000000 -1762 0 100.000000 -1763 0 100.000000 -1764 0 100.000000 -1765 0 100.000000 -1766 0 100.000000 -1767 0 100.000000 -1768 0 100.000000 -1769 0 100.000000 -1770 0 100.000000 -1771 0 100.000000 -1772 0 100.000000 -1773 0 100.000000 -1774 0 100.000000 -1775 0 100.000000 -1776 0 100.000000 -1777 0 100.000000 -1778 0 100.000000 -1779 0 100.000000 -1780 0 100.000000 -1781 0 100.000000 -1782 0 100.000000 -1783 0 100.000000 -1784 0 100.000000 -1785 0 100.000000 -1786 0 100.000000 -1787 0 100.000000 -1788 0 100.000000 -1789 0 100.000000 -1790 0 100.000000 -1791 0 100.000000 -1792 0 100.000000 -1793 0 100.000000 -1794 0 100.000000 -1795 0 100.000000 -1796 0 100.000000 -1797 0 100.000000 -1798 0 100.000000 -1799 0 100.000000 -1800 0 100.000000 -1801 0 100.000000 -1802 0 100.000000 -1803 0 100.000000 -1804 0 100.000000 -1805 0 100.000000 -1806 0 100.000000 -1807 0 100.000000 -1808 0 100.000000 -1809 0 100.000000 -1810 0 100.000000 -1811 0 100.000000 -1812 0 100.000000 -1813 0 100.000000 -1814 0 100.000000 -1815 0 100.000000 -1816 0 100.000000 -1817 0 100.000000 -1818 0 100.000000 -1819 0 100.000000 -1820 0 100.000000 -1821 0 100.000000 -1822 0 100.000000 -1823 0 100.000000 -1824 0 100.000000 -1825 0 100.000000 -1826 0 100.000000 -1827 0 100.000000 -1828 0 100.000000 -1829 0 100.000000 -1830 0 100.000000 -1831 0 100.000000 -1832 0 100.000000 -1833 0 100.000000 -1834 0 100.000000 -1835 0 100.000000 -1836 0 100.000000 -1837 0 100.000000 -1838 0 100.000000 -1839 0 100.000000 -1840 0 100.000000 -1841 0 100.000000 -1842 0 100.000000 -1843 0 100.000000 -1844 0 100.000000 -1845 0 100.000000 -1846 0 100.000000 -1847 0 100.000000 -1848 0 100.000000 -1849 0 100.000000 -1850 0 100.000000 -1851 0 100.000000 -1852 0 100.000000 -1853 0 100.000000 -1854 0 100.000000 -1855 0 100.000000 -1856 0 100.000000 -1857 0 100.000000 -1858 0 100.000000 -1859 0 100.000000 -1860 0 100.000000 -1861 0 100.000000 -1862 0 100.000000 -1863 0 100.000000 -1864 0 100.000000 -1865 0 100.000000 -1866 0 100.000000 -1867 0 100.000000 -1868 0 100.000000 -1869 0 100.000000 -1870 0 100.000000 -1871 0 100.000000 -1872 0 100.000000 -1873 0 100.000000 -1874 0 100.000000 -1875 0 100.000000 -1876 0 100.000000 -1877 0 100.000000 -1878 0 100.000000 -1879 0 100.000000 -1880 0 100.000000 -1881 0 100.000000 -1882 0 100.000000 -1883 0 100.000000 -1884 0 100.000000 -1885 0 100.000000 -1886 0 100.000000 -1887 0 100.000000 -1888 0 100.000000 -1889 0 100.000000 -1890 0 100.000000 -1891 0 100.000000 -1892 0 100.000000 -1893 0 100.000000 -1894 0 100.000000 -1895 0 100.000000 -1896 0 100.000000 -1897 0 100.000000 -1898 0 100.000000 -1899 0 100.000000 -1900 0 100.000000 -1901 0 100.000000 -1902 0 100.000000 -1903 0 100.000000 -1904 0 100.000000 -1905 0 100.000000 -1906 0 100.000000 -1907 0 100.000000 -1908 0 100.000000 -1909 0 100.000000 -1910 0 100.000000 -1911 0 100.000000 -1912 0 100.000000 -1913 0 100.000000 -1914 0 100.000000 -1915 0 100.000000 -1916 0 100.000000 -1917 0 100.000000 -1918 0 100.000000 -1919 0 100.000000 -1920 0 100.000000 -1921 0 100.000000 -1922 0 100.000000 -1923 0 100.000000 -1924 0 100.000000 -1925 0 100.000000 -1926 0 100.000000 -1927 0 100.000000 -1928 0 100.000000 -1929 0 100.000000 -1930 0 100.000000 -1931 0 100.000000 -1932 0 100.000000 -1933 0 100.000000 -1934 0 100.000000 -1935 0 100.000000 -1936 0 100.000000 -1937 0 100.000000 -1938 0 100.000000 -1939 0 100.000000 -1940 0 100.000000 -1941 0 100.000000 -1942 0 100.000000 -1943 0 100.000000 -1944 0 100.000000 -1945 0 100.000000 -1946 0 100.000000 -1947 0 100.000000 -1948 0 100.000000 -1949 0 100.000000 -1950 0 100.000000 -1951 0 100.000000 -1952 0 100.000000 -1953 0 100.000000 -1954 0 100.000000 -1955 0 100.000000 -1956 0 100.000000 -1957 0 100.000000 -1958 0 100.000000 -1959 0 100.000000 -1960 0 100.000000 -1961 0 100.000000 -1962 0 100.000000 -1963 0 100.000000 -1964 0 100.000000 -1965 0 100.000000 -1966 0 100.000000 -1967 0 100.000000 -1968 0 100.000000 -1969 0 100.000000 -1970 0 100.000000 -1971 0 100.000000 -1972 0 100.000000 -1973 0 100.000000 -1974 0 100.000000 -1975 0 100.000000 -1976 0 100.000000 -1977 0 100.000000 -1978 0 100.000000 -1979 0 100.000000 -1980 0 100.000000 -1981 0 100.000000 -1982 0 100.000000 -1983 0 100.000000 -1984 0 100.000000 -1985 0 100.000000 -1986 0 100.000000 -1987 0 100.000000 -1988 0 100.000000 -1989 0 100.000000 -1990 0 100.000000 -1991 0 100.000000 -1992 0 100.000000 -1993 0 100.000000 -1994 0 100.000000 -1995 0 100.000000 -1996 0 100.000000 -1997 0 100.000000 -1998 0 100.000000 -1999 0 100.000000 -2000 0 100.000000 -2001 0 100.000000 -2002 0 100.000000 -2003 0 100.000000 -2004 0 100.000000 -2005 0 100.000000 -2006 0 100.000000 -2007 0 100.000000 -2008 0 100.000000 -2009 0 100.000000 -2010 0 100.000000 -2011 0 100.000000 -2012 0 100.000000 -2013 0 100.000000 -2014 0 100.000000 -2015 0 100.000000 -2016 0 100.000000 -2017 0 100.000000 -2018 0 100.000000 -2019 0 100.000000 -2020 0 100.000000 -2021 0 100.000000 -2022 0 100.000000 -2023 0 100.000000 -2024 0 100.000000 -2025 0 100.000000 -2026 0 100.000000 -2027 0 100.000000 -2028 0 100.000000 -2029 0 100.000000 -2030 0 100.000000 -2031 0 100.000000 -2032 0 100.000000 -2033 0 100.000000 -2034 0 100.000000 -2035 0 100.000000 -2036 0 100.000000 -2037 0 100.000000 -2038 0 100.000000 -2039 0 100.000000 -2040 0 100.000000 -2041 0 100.000000 -2042 0 100.000000 -2043 0 100.000000 -2044 0 100.000000 -2045 0 100.000000 -2046 0 100.000000 -2047 0 100.000000 -2048 0 100.000000 -2049 0 100.000000 -2050 0 100.000000 -2051 0 100.000000 -2052 0 100.000000 -2053 0 100.000000 -2054 0 100.000000 -2055 0 100.000000 -2056 0 100.000000 -2057 0 100.000000 -2058 0 100.000000 -2059 0 100.000000 -2060 0 100.000000 -2061 0 100.000000 -2062 0 100.000000 -2063 0 100.000000 -2064 0 100.000000 -2065 0 100.000000 -2066 0 100.000000 -2067 0 100.000000 -2068 0 100.000000 -2069 0 100.000000 -2070 0 100.000000 -2071 0 100.000000 -2072 0 100.000000 -2073 0 100.000000 -2074 0 100.000000 -2075 0 100.000000 -2076 0 100.000000 -2077 0 100.000000 -2078 0 100.000000 -2079 0 100.000000 -2080 0 100.000000 -2081 0 100.000000 -2082 0 100.000000 -2083 0 100.000000 -2084 0 100.000000 -2085 0 100.000000 -2086 0 100.000000 -2087 0 100.000000 -2088 0 100.000000 -2089 0 100.000000 -2090 0 100.000000 -2091 0 100.000000 -2092 0 100.000000 -2093 0 100.000000 -2094 0 100.000000 -2095 0 100.000000 -2096 0 100.000000 -2097 0 100.000000 -2098 0 100.000000 -2099 0 100.000000 -2100 0 100.000000 -2101 0 100.000000 -2102 0 100.000000 -2103 0 100.000000 -2104 0 100.000000 -2105 0 100.000000 -2106 0 100.000000 -2107 0 100.000000 -2108 0 100.000000 -2109 0 100.000000 -2110 0 100.000000 -2111 0 100.000000 -2112 0 100.000000 -2113 0 100.000000 -2114 0 100.000000 -2115 0 100.000000 -2116 0 100.000000 -2117 0 100.000000 -2118 0 100.000000 -2119 0 100.000000 -2120 0 100.000000 -2121 0 100.000000 -2122 0 100.000000 -2123 0 100.000000 -2124 0 100.000000 -2125 0 100.000000 -2126 0 100.000000 -2127 0 100.000000 -2128 0 100.000000 -2129 0 100.000000 -2130 0 100.000000 -2131 0 100.000000 -2132 0 100.000000 -2133 0 100.000000 -2134 0 100.000000 -2135 0 100.000000 -2136 0 100.000000 -2137 0 100.000000 -2138 0 100.000000 -2139 0 100.000000 -2140 0 100.000000 -2141 0 100.000000 -2142 0 100.000000 -2143 0 100.000000 -2144 0 100.000000 -2145 0 100.000000 -2146 0 100.000000 -2147 0 100.000000 -2148 0 100.000000 -2149 0 100.000000 -2150 0 100.000000 -2151 0 100.000000 -2152 0 100.000000 -2153 0 100.000000 -2154 0 100.000000 -2155 0 100.000000 -2156 0 100.000000 -2157 0 100.000000 -2158 0 100.000000 -2159 0 100.000000 -2160 0 100.000000 -2161 0 100.000000 -2162 0 100.000000 -2163 0 100.000000 -2164 0 100.000000 -2165 0 100.000000 -2166 0 100.000000 -2167 0 100.000000 -2168 0 100.000000 -2169 0 100.000000 -2170 0 100.000000 -2171 0 100.000000 -2172 0 100.000000 -2173 0 100.000000 -2174 0 100.000000 -2175 0 100.000000 -2176 0 100.000000 -2177 0 100.000000 -2178 0 100.000000 -2179 0 100.000000 -2180 0 100.000000 -2181 0 100.000000 -2182 0 100.000000 -2183 0 100.000000 -2184 0 100.000000 -2185 0 100.000000 -2186 0 100.000000 -2187 0 100.000000 -2188 0 100.000000 -2189 0 100.000000 -2190 0 100.000000 -2191 0 100.000000 -2192 0 100.000000 -2193 0 100.000000 -2194 0 100.000000 -2195 0 100.000000 -2196 0 100.000000 -2197 0 100.000000 -2198 0 100.000000 -2199 0 100.000000 -2200 0 100.000000 -2201 0 100.000000 -2202 0 100.000000 -2203 0 100.000000 -2204 0 100.000000 -2205 0 100.000000 -2206 0 100.000000 -2207 0 100.000000 -2208 0 100.000000 -2209 0 100.000000 -2210 0 100.000000 -2211 0 100.000000 -2212 0 100.000000 -2213 0 100.000000 -2214 0 100.000000 -2215 0 100.000000 -2216 0 100.000000 -2217 0 100.000000 -2218 0 100.000000 -2219 0 100.000000 -2220 0 100.000000 -2221 0 100.000000 -2222 0 100.000000 -2223 0 100.000000 -2224 0 100.000000 -2225 0 100.000000 -2226 0 100.000000 -2227 0 100.000000 -2228 0 100.000000 -2229 0 100.000000 -2230 0 100.000000 -2231 0 100.000000 -2232 0 100.000000 -2233 0 100.000000 -2234 0 100.000000 -2235 0 100.000000 -2236 0 100.000000 -2237 0 100.000000 -2238 0 100.000000 -2239 0 100.000000 -2240 0 100.000000 -2241 0 100.000000 -2242 0 100.000000 -2243 0 100.000000 -2244 0 100.000000 -2245 0 100.000000 -2246 0 100.000000 -2247 0 100.000000 -2248 0 100.000000 -2249 0 100.000000 -2250 0 100.000000 -2251 0 100.000000 -2252 0 100.000000 -2253 0 100.000000 -2254 0 100.000000 -2255 0 100.000000 -2256 0 100.000000 -2257 0 100.000000 -2258 0 100.000000 -2259 0 100.000000 -2260 0 100.000000 -2261 0 100.000000 -2262 0 100.000000 -2263 0 100.000000 -2264 0 100.000000 -2265 0 100.000000 -2266 0 100.000000 -2267 0 100.000000 -2268 0 100.000000 -2269 0 100.000000 -2270 0 100.000000 -2271 0 100.000000 -2272 0 100.000000 -2273 0 100.000000 -2274 0 100.000000 -2275 0 100.000000 -2276 0 100.000000 -2277 0 100.000000 -2278 0 100.000000 -2279 0 100.000000 -2280 0 100.000000 -2281 0 100.000000 -2282 0 100.000000 -2283 0 100.000000 -2284 0 100.000000 -2285 0 100.000000 -2286 0 100.000000 -2287 0 100.000000 -2288 0 100.000000 -2289 0 100.000000 -2290 0 100.000000 -2291 0 100.000000 -2292 0 100.000000 -2293 0 100.000000 -2294 0 100.000000 -2295 0 100.000000 -2296 0 100.000000 -2297 0 100.000000 -2298 0 100.000000 -2299 0 100.000000 -2300 0 100.000000 -2301 0 100.000000 -2302 0 100.000000 -2303 0 100.000000 -2304 0 100.000000 -2305 0 100.000000 -2306 0 100.000000 -2307 0 100.000000 -2308 0 100.000000 -2309 0 100.000000 -2310 0 100.000000 -2311 0 100.000000 -2312 0 100.000000 -2313 0 100.000000 -2314 0 100.000000 -2315 0 100.000000 -2316 0 100.000000 -2317 0 100.000000 -2318 0 100.000000 -2319 0 100.000000 -2320 0 100.000000 -2321 0 100.000000 -2322 0 100.000000 -2323 0 100.000000 -2324 0 100.000000 -2325 0 100.000000 -2326 0 100.000000 -2327 0 100.000000 -2328 0 100.000000 -2329 0 100.000000 -2330 0 100.000000 -2331 0 100.000000 -2332 0 100.000000 -2333 0 100.000000 -2334 0 100.000000 -2335 0 100.000000 -2336 0 100.000000 -2337 0 100.000000 -2338 0 100.000000 -2339 0 100.000000 -2340 0 100.000000 -2341 0 100.000000 -2342 0 100.000000 -2343 0 100.000000 -2344 0 100.000000 -2345 0 100.000000 -2346 0 100.000000 -2347 0 100.000000 -2348 0 100.000000 -2349 0 100.000000 -2350 0 100.000000 -2351 0 100.000000 -2352 0 100.000000 -2353 0 100.000000 -2354 0 100.000000 -2355 0 100.000000 -2356 0 100.000000 -2357 0 100.000000 -2358 0 100.000000 -2359 0 100.000000 -2360 0 100.000000 -2361 0 100.000000 -2362 0 100.000000 -2363 0 100.000000 -2364 0 100.000000 -2365 0 100.000000 -2366 0 100.000000 -2367 0 100.000000 -2368 0 100.000000 -2369 0 100.000000 -2370 0 100.000000 -2371 0 100.000000 -2372 0 100.000000 -2373 0 100.000000 -2374 0 100.000000 -2375 0 100.000000 -2376 0 100.000000 -2377 0 100.000000 -2378 0 100.000000 -2379 0 100.000000 -2380 0 100.000000 -2381 0 100.000000 -2382 0 100.000000 -2383 0 100.000000 -2384 0 100.000000 -2385 0 100.000000 -2386 0 100.000000 -2387 0 100.000000 -2388 0 100.000000 -2389 0 100.000000 -2390 0 100.000000 -2391 0 100.000000 -2392 0 100.000000 -2393 0 100.000000 -2394 0 100.000000 -2395 0 100.000000 -2396 0 100.000000 -2397 0 100.000000 -2398 0 100.000000 -2399 0 100.000000 -2400 0 100.000000 -2401 0 100.000000 -2402 0 100.000000 -2403 0 100.000000 -2404 0 100.000000 -2405 0 100.000000 -2406 0 100.000000 -2407 0 100.000000 -2408 0 100.000000 -2409 0 100.000000 -2410 0 100.000000 -2411 0 100.000000 -2412 0 100.000000 -2413 0 100.000000 -2414 0 100.000000 -2415 0 100.000000 -2416 0 100.000000 -2417 0 100.000000 -2418 0 100.000000 -2419 0 100.000000 -2420 0 100.000000 -2421 0 100.000000 -2422 0 100.000000 -2423 0 100.000000 -2424 0 100.000000 -2425 0 100.000000 -2426 0 100.000000 -2427 0 100.000000 -2428 0 100.000000 -2429 0 100.000000 -2430 0 100.000000 -2431 0 100.000000 -2432 0 100.000000 -2433 0 100.000000 -2434 0 100.000000 -2435 0 100.000000 -2436 0 100.000000 -2437 0 100.000000 -2438 0 100.000000 -2439 0 100.000000 -2440 0 100.000000 -2441 0 100.000000 -2442 0 100.000000 -2443 0 100.000000 -2444 0 100.000000 -2445 0 100.000000 -2446 0 100.000000 -2447 0 100.000000 -2448 0 100.000000 -2449 0 100.000000 -2450 0 100.000000 -2451 0 100.000000 -2452 0 100.000000 -2453 0 100.000000 -2454 0 100.000000 -2455 0 100.000000 -2456 0 100.000000 -2457 0 100.000000 -2458 0 100.000000 -2459 0 100.000000 -2460 0 100.000000 -2461 0 100.000000 -2462 0 100.000000 -2463 0 100.000000 -2464 0 100.000000 -2465 0 100.000000 -2466 0 100.000000 -2467 0 100.000000 -2468 0 100.000000 -2469 0 100.000000 -2470 0 100.000000 -2471 0 100.000000 -2472 0 100.000000 -2473 0 100.000000 -2474 0 100.000000 -2475 0 100.000000 -2476 0 100.000000 -2477 0 100.000000 -2478 0 100.000000 -2479 0 100.000000 -2480 0 100.000000 -2481 0 100.000000 -2482 0 100.000000 -2483 0 100.000000 -2484 0 100.000000 -2485 0 100.000000 -2486 0 100.000000 -2487 0 100.000000 -2488 0 100.000000 -2489 0 100.000000 -2490 0 100.000000 -2491 0 100.000000 -2492 0 100.000000 -2493 0 100.000000 -2494 0 100.000000 -2495 0 100.000000 -2496 0 100.000000 -2497 0 100.000000 -2498 0 100.000000 -2499 0 100.000000 -2500 0 100.000000 -2501 0 100.000000 -2502 0 100.000000 -2503 0 100.000000 -2504 0 100.000000 -2505 0 100.000000 -2506 0 100.000000 -2507 0 100.000000 -2508 0 100.000000 -2509 0 100.000000 -2510 0 100.000000 -2511 0 100.000000 -2512 0 100.000000 -2513 0 100.000000 -2514 0 100.000000 -2515 0 100.000000 -2516 0 100.000000 -2517 0 100.000000 -2518 0 100.000000 -2519 0 100.000000 -2520 0 100.000000 -2521 0 100.000000 -2522 0 100.000000 -2523 0 100.000000 -2524 0 100.000000 -2525 0 100.000000 -2526 0 100.000000 -2527 0 100.000000 -2528 0 100.000000 -2529 0 100.000000 -2530 0 100.000000 -2531 0 100.000000 -2532 0 100.000000 -2533 0 100.000000 -2534 0 100.000000 -2535 0 100.000000 -2536 0 100.000000 -2537 0 100.000000 -2538 0 100.000000 -2539 0 100.000000 -2540 0 100.000000 -2541 0 100.000000 -2542 0 100.000000 -2543 0 100.000000 -2544 0 100.000000 -2545 0 100.000000 -2546 0 100.000000 -2547 0 100.000000 -2548 0 100.000000 -2549 0 100.000000 -2550 0 100.000000 -2551 0 100.000000 -2552 0 100.000000 -2553 0 100.000000 -2554 0 100.000000 -2555 0 100.000000 -2556 0 100.000000 -2557 0 100.000000 -2558 0 100.000000 -2559 0 100.000000 -2560 0 100.000000 -2561 0 100.000000 -2562 0 100.000000 -2563 0 100.000000 -2564 0 100.000000 -2565 0 100.000000 -2566 0 100.000000 -2567 0 100.000000 -2568 0 100.000000 -2569 0 100.000000 -2570 0 100.000000 -2571 0 100.000000 -2572 0 100.000000 -2573 0 100.000000 -2574 0 100.000000 -2575 0 100.000000 -2576 0 100.000000 -2577 0 100.000000 -2578 0 100.000000 -2579 0 100.000000 -2580 0 100.000000 -2581 0 100.000000 -2582 0 100.000000 -2583 0 100.000000 -2584 0 100.000000 -2585 0 100.000000 -2586 0 100.000000 -2587 0 100.000000 -2588 0 100.000000 -2589 0 100.000000 -2590 0 100.000000 -2591 0 100.000000 -2592 0 100.000000 -2593 0 100.000000 -2594 0 100.000000 -2595 0 100.000000 -2596 0 100.000000 -2597 0 100.000000 -2598 0 100.000000 -2599 0 100.000000 -2600 0 100.000000 -2601 0 100.000000 -2602 0 100.000000 -2603 0 100.000000 -2604 0 100.000000 -2605 0 100.000000 -2606 0 100.000000 -2607 0 100.000000 -2608 0 100.000000 -2609 0 100.000000 -2610 0 100.000000 -2611 0 100.000000 -2612 0 100.000000 -2613 0 100.000000 -2614 0 100.000000 -2615 0 100.000000 -2616 0 100.000000 -2617 0 100.000000 -2618 0 100.000000 -2619 0 100.000000 -2620 0 100.000000 -2621 0 100.000000 -2622 0 100.000000 -2623 0 100.000000 -2624 0 100.000000 -2625 0 100.000000 -2626 0 100.000000 -2627 0 100.000000 -2628 0 100.000000 -2629 0 100.000000 -2630 0 100.000000 -2631 0 100.000000 -2632 0 100.000000 -2633 0 100.000000 -2634 0 100.000000 -2635 0 100.000000 -2636 0 100.000000 -2637 0 100.000000 -2638 0 100.000000 -2639 0 100.000000 -2640 0 100.000000 -2641 0 100.000000 -2642 0 100.000000 -2643 0 100.000000 -2644 0 100.000000 -2645 0 100.000000 -2646 0 100.000000 -2647 0 100.000000 -2648 0 100.000000 -2649 0 100.000000 -2650 0 100.000000 -2651 0 100.000000 -2652 0 100.000000 -2653 0 100.000000 -2654 0 100.000000 -2655 0 100.000000 -2656 0 100.000000 -2657 0 100.000000 -2658 0 100.000000 -2659 0 100.000000 -2660 0 100.000000 -2661 0 100.000000 -2662 0 100.000000 -2663 0 100.000000 -2664 0 100.000000 -2665 0 100.000000 -2666 0 100.000000 -2667 0 100.000000 -2668 0 100.000000 -2669 0 100.000000 -2670 0 100.000000 -2671 0 100.000000 -2672 0 100.000000 -2673 0 100.000000 -2674 0 100.000000 -2675 0 100.000000 -2676 0 100.000000 -2677 0 100.000000 -2678 0 100.000000 -2679 0 100.000000 -2680 0 100.000000 -2681 0 100.000000 -2682 0 100.000000 -2683 0 100.000000 -2684 0 100.000000 -2685 0 100.000000 -2686 0 100.000000 -2687 0 100.000000 -2688 0 100.000000 -2689 0 100.000000 -2690 0 100.000000 -2691 0 100.000000 -2692 0 100.000000 -2693 0 100.000000 -2694 0 100.000000 -2695 0 100.000000 -2696 0 100.000000 -2697 0 100.000000 -2698 0 100.000000 -2699 0 100.000000 -2700 0 100.000000 -2701 0 100.000000 -2702 0 100.000000 -2703 0 100.000000 -2704 0 100.000000 -2705 0 100.000000 -2706 0 100.000000 -2707 0 100.000000 -2708 0 100.000000 -2709 0 100.000000 -2710 0 100.000000 -2711 0 100.000000 -2712 0 100.000000 -2713 0 100.000000 -2714 0 100.000000 -2715 0 100.000000 -2716 0 100.000000 -2717 0 100.000000 -2718 0 100.000000 -2719 0 100.000000 -2720 0 100.000000 -2721 0 100.000000 -2722 0 100.000000 -2723 0 100.000000 -2724 0 100.000000 -2725 0 100.000000 -2726 0 100.000000 -2727 0 100.000000 -2728 0 100.000000 -2729 0 100.000000 -2730 0 100.000000 -2731 0 100.000000 -2732 0 100.000000 -2733 0 100.000000 -2734 0 100.000000 -2735 0 100.000000 -2736 0 100.000000 -2737 0 100.000000 -2738 0 100.000000 -2739 0 100.000000 -2740 0 100.000000 -2741 0 100.000000 -2742 0 100.000000 -2743 0 100.000000 -2744 0 100.000000 -2745 0 100.000000 -2746 0 100.000000 -2747 0 100.000000 -2748 0 100.000000 -2749 0 100.000000 -2750 0 100.000000 -2751 0 100.000000 -2752 0 100.000000 -2753 0 100.000000 -2754 0 100.000000 -2755 0 100.000000 -2756 0 100.000000 -2757 0 100.000000 -2758 0 100.000000 -2759 0 100.000000 -2760 0 100.000000 -2761 0 100.000000 -2762 0 100.000000 -2763 0 100.000000 -2764 0 100.000000 -2765 0 100.000000 -2766 0 100.000000 -2767 0 100.000000 -2768 0 100.000000 -2769 0 100.000000 -2770 0 100.000000 -2771 0 100.000000 -2772 0 100.000000 -2773 0 100.000000 -2774 0 100.000000 -2775 0 100.000000 -2776 0 100.000000 -2777 0 100.000000 -2778 0 100.000000 -2779 0 100.000000 -2780 0 100.000000 -2781 0 100.000000 -2782 0 100.000000 -2783 0 100.000000 -2784 0 100.000000 -2785 0 100.000000 -2786 0 100.000000 -2787 0 100.000000 -2788 0 100.000000 -2789 0 100.000000 -2790 0 100.000000 -2791 0 100.000000 -2792 0 100.000000 -2793 0 100.000000 -2794 0 100.000000 -2795 0 100.000000 -2796 0 100.000000 -2797 0 100.000000 -2798 0 100.000000 -2799 0 100.000000 -2800 0 100.000000 -2801 0 100.000000 -2802 0 100.000000 -2803 0 100.000000 -2804 0 100.000000 -2805 0 100.000000 -2806 0 100.000000 -2807 0 100.000000 -2808 0 100.000000 -2809 0 100.000000 -2810 0 100.000000 -2811 0 100.000000 -2812 0 100.000000 -2813 0 100.000000 -2814 0 100.000000 -2815 0 100.000000 -2816 0 100.000000 -2817 0 100.000000 -2818 0 100.000000 -2819 0 100.000000 -2820 0 100.000000 -2821 0 100.000000 -2822 0 100.000000 -2823 0 100.000000 -2824 0 100.000000 -2825 0 100.000000 -2826 0 100.000000 -2827 0 100.000000 -2828 0 100.000000 -2829 0 100.000000 -2830 0 100.000000 -2831 0 100.000000 -2832 0 100.000000 -2833 0 100.000000 -2834 0 100.000000 -2835 0 100.000000 -2836 0 100.000000 -End NodalData - - - diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.msh b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.msh deleted file mode 100755 index 25ee286ec95b..000000000000 Binary files a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.msh and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.node b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.node deleted file mode 100755 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.png b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.png deleted file mode 100755 index d7ddfda267e7..000000000000 Binary files a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.png and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.prb b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.prb deleted file mode 100755 index 25297e1f7110..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.prb +++ /dev/null @@ -1,46 +0,0 @@ -PROBLEM DATA -BOOK: Default Elements -QUESTION: 2D_Boundary_Condition#CB#(Condition2D,Fluid2DNeumann,Monolithic2DNeumann) -VALUE: Condition2D -QUESTION: 3D_Boundary_Condition#CB#(Condition3D,Fluid3DNeumann,Monolithic3DNeumann) -VALUE: Condition3D -QUESTION: 2D_Body_Element#CB#(Fluid2D,Fluid2DCoupled,ASGS2D,ASGSCompressible2D,NoNewtonianASGS2D,CouetteNonNewtonianASGS2D) -VALUE: Fluid2D -QUESTION: 3D_Body_Element#CB#(Fluid3D,Fluid3DCoupled,ASGS3D) -VALUE: Fluid3D -BOOK: Problem Parameters -QUESTION: Python_script_file#CB#(Use_Default,Do_not_write,Copy_From,Use_Current) -VALUE: Use_Default -DEPENDENCIES: (Use_Default,SET,Python_file,#CURRENT#)(Do_not_write,SET,Python_file,#CURRENT#)(Copy_From,RESTORE,Python_file,#CURRENT#)(Use_Current,SET,Python_file,#CURRENT#) -QUESTION: Python_file -VALUE: script.py -TKWIDGET: TkwidgetFilePath -QUESTION: Transfer_materials_to_lower_entities#CB#(1,0) -VALUE: 1 -QUESTION: Let_GiD_determine_domain_size#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (1,HIDE,DOMAIN_SIZE,#CURRENT#)(0,RESTORE,DOMAIN_SIZE,#CURRENT#) -QUESTION: DOMAIN_SIZE#CB#(2,3) -VALUE: 2 -STATE: HIDDEN -QUESTION: Time_step -VALUE: 0.01 -QUESTION: max_time -VALUE: 3.5 -QUESTION: SolverType#CB#(fractional_step,pressure_splitting,monolithic_solver_eulerian) -VALUE: monolithic_solver_eulerian -QUESTION: laplacian_form -VALUE: 1 -QUESTION: output_step -VALUE: 1 -QUESTION: predictor_corrector -VALUE: False -QUESTION: max_press_its -VALUE: 3 -QUESTION: use_oss -VALUE: 0 -QUESTION: dynamic_tau -VALUE: 1.0 -END PROBLEM DATA -INTERVAL DATA -END INTERVAL DATA diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.prop b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.prop deleted file mode 100755 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.rdr b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.rdr deleted file mode 100755 index acceb4671cd8..000000000000 Binary files a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.rdr and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.vv b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.vv deleted file mode 100755 index a10c6a5a5492..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.vv +++ /dev/null @@ -1,19 +0,0 @@ -BeginZE /home/antonia/kratos/applications/PFEMapplication/test_exemples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.vv - x 2.02824 3.90821 - y 1.14744 -0.425479 - z -9.94987 9.94987 - e 3.31662 - v 2.18557e-08 1.91069e-15 -8.74228e-08 - r -1 - m 1 -1.74846e-07 -7.64274e-15 0 1.74846e-07 1 4.37114e-08 0 0 -4.37114e-08 1 0 0 0 0 1 - c 3 0.5 0 - pd 0 - pno 0 - pfo 0 - pf 4 - pv 0 - NowUse 1 - DrawingType 0 - LightVector 90 90 150 0 -EndZE /home/antonia/kratos/applications/PFEMapplication/test_exemples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d.vv - diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d_aux.unix.bat b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d_aux.unix.bat deleted file mode 100755 index b6fa9bff004e..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d_aux.unix.bat +++ /dev/null @@ -1,25 +0,0 @@ -#!/bin/bash -i - -write_python_file="Use_Default" -file_location="script.py" -problemtype_name=fluid_only - -mv $2/$1-3.dat $2/${problemtype_name}_var.py - -echo "problem_name=\"${1}\"" >> ${problemtype_name}_var.py -echo "problem_path=\"${2}\"" >> ${problemtype_name}_var.py -echo "kratos_path=\"${KRATOS_PATH}\"" >> ${problemtype_name}_var.py - -if [ $write_python_file = "Use_Default" ] -then - cp $3/script.py $2/ -# cp $3/run_example_trilinos.py $2/ -elif [ $write_python_file = "Copy_From" ] -then - cp $file_location $2/script.py -fi - -if [ -f script.py ] -then - python $2/script.py >& $2/$1.info -fi diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d_out.mdpa b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/CouetteNonNewtonian2d_out.mdpa deleted file mode 100755 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette_benchmark.py b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette_benchmark.py deleted file mode 100755 index 59e6b47fb402..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette_benchmark.py +++ /dev/null @@ -1,22 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import sys -kratos_benchmarking_path = '../../../../benchmarking' -sys.path.append(kratos_benchmarking_path) -import benchmarking - -Text = " " - -# -print("verifying Couette2dNonNewt.py...") -successful,Msg = benchmarking.RunBenchmark("Couette2dNonNewt.py", "Couette2dNonNewt_ref.txt") - -if(successful==True): - Text += "OK\n" - print("Couette2dNonNewt example SUCCESFUL") -else: - Text += "FAILED\n" - Text += Msg - Text += "\n\n" - print("Couette2dNonNewt example FAILED") - -print(Text) diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette_build_reference.py b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette_build_reference.py deleted file mode 100755 index 715242a73a25..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/Couette_build_reference.py +++ /dev/null @@ -1,8 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import sys -kratos_benchmarking_path = '../../../../benchmarking' -sys.path.append(kratos_benchmarking_path) -import benchmarking - -print("Building reference data for Couette2dNonNewt.py...") -benchmarking.BuildReferenceData("Couette2dNonNewt.py", "Couette2dNonNewt_ref.txt") diff --git a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/fluid_only_var.py b/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/fluid_only_var.py deleted file mode 100755 index 73e68ddfb1b2..000000000000 --- a/applications/PFEMapplication/test_examples/CouetteNonNewtonian2d.gid/fluid_only_var.py +++ /dev/null @@ -1,17 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -domain_size = 2 - -Dt = 0.01 -max_time = 3.5 -SolverType = "monolithic_solver_eulerian" -laplacian_form = 1 -output_step = 1 -predictor_corrector = False -max_press_its = 3 -use_oss = 0 -dynamic_tau = 1.0 -# Declare Python Variables - -problem_name = "CouetteNonNewtonian2d" -problem_path = "/media/data/EXAMPLES/PFEM/NON_NEWTONIAN/COUETTEflow/CouetteNonNewtonian2d.gid" -kratos_path = "/home/antonia/kratos" diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope.py b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope.py deleted file mode 100644 index e4cc5d3a6640..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope.py +++ /dev/null @@ -1,449 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# import the configuration data as read from the GiD -import pfem_nonewtonian_coupled_var_benchmark -import time -# -# -# setting the domain size for the problem to be solved -domain_size = pfem_nonewtonian_coupled_var_benchmark.domain_size - -# -# -# ATTENTION: here the order is important - -# including kratos path -kratos_path = '../../../../' # kratos_root -kratos_benchmarking_path = '../../../../benchmarking' # kratos_root/benchmarking -import sys -sys.path.append(kratos_path) -sys.path.append(kratos_benchmarking_path) -import benchmarking - - -# importing Kratos main library -from KratosMultiphysics import * - -from KratosMultiphysics.StructuralApplication import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * -from KratosMultiphysics.ExternalSolversApplication import* - - -# from now on the order is not anymore crucial -# -# -import math -import edgebased_levelset_var -import edgebased_levelset_solver - - -# import cProfile -# defining the two model part: pfem_model_part and fixed_model_part -pfem_model_part = ModelPart("PfemFluidPart") -fixed_model_part = ModelPart("FixedFluidPart") - -# Benchmarking - - -def NodeFinder(node_list, X, Y, Z): - for node in node_list: - if((node.X - X) ** 2 + (node.Y - Y) ** 2 + (node.Z -Z)**2 < .0001): - return node - - -def BenchmarkCheck(time, node1): - benchmarking.Output(time, "Time", 1.0, 1.0) -# print "IIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIII" - benchmarking.Output(node1.GetSolutionStepValue(PRESSURE), "Node 1 pressure", 1.0, 1.0) - benchmarking.Output(node1.GetSolutionStepValue(VELOCITY_Y), "Node 1 velocity_y", 0.1, 0.0001) - -# importing the fluid_solver files and adding the variablesv -edgebased_levelset_solver.AddVariables(fixed_model_part) -fixed_model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) -fixed_model_part.AddNodalSolutionStepVariable(POROSITY) -fixed_model_part.AddNodalSolutionStepVariable(DIAMETER) -# fixed_model_part.AddNodalSolutionStepVariable(SEEPAGE_DRAG) -# fixed_model_part.AddNodalSolutionStepVariable(VISCOSITY) - -# importing the structural_solver files and adding the variables -SolverType = pfem_nonewtonian_coupled_var_benchmark.SolverType -if(SolverType == "pfem_solver_ale"): - print("Pfem_solver_ale_not supported. Check to be using nonewtonian_asgs2d (or 3d) element") -elif(SolverType == "monolithic_solver_lagrangian"): - import monolithic_solver_lagrangian_nonnewtonian - monolithic_solver_lagrangian_nonnewtonian.AddVariables(pfem_model_part) - pfem_model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) - pfem_model_part.AddNodalSolutionStepVariable(IS_VISITED) - pfem_model_part.AddNodalSolutionStepVariable(IS_EROSIONABLE) - pfem_model_part.AddNodalSolutionStepVariable(FRICTION_COEFFICIENT) - pfem_model_part.AddNodalSolutionStepVariable(POROSITY) - pfem_model_part.AddNodalSolutionStepVariable(NODAL_MASS) - pfem_model_part.AddNodalSolutionStepVariable(DIAMETER) -# pfem_model_part.AddNodalSolutionStepVariable(SEEPAGE_DRAG) - pfem_model_part.AddNodalSolutionStepVariable(WATER_PRESSURE) -else: - raise "solver type not supported: options are FractionalStep - Monolithic" - - -# reading the models -name_pfem = pfem_nonewtonian_coupled_var_benchmark.problem_name -name_fixed = pfem_nonewtonian_coupled_var_benchmark.fluid_file - - -gid_mode = GiDPostMode.GiD_PostBinary -multifile = MultiFileFlag.MultipleFiles -deformed_mesh_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteElementsOnly - -# READING FROM MULTIPLE .gid FILES######################## -# reading the pfem model part -gid_io = EdgebasedGidIO(name_pfem, gid_mode, multifile, deformed_mesh_flag, write_conditions) -model_part_io_structure = ModelPartIO(name_pfem) -model_part_io_structure.ReadModelPart(pfem_model_part) -print("pfem model read correctly") -# reading the fixed model part with the new porblem type format -model_part_io_fluid = ModelPartIO(name_fixed) -model_part_io_fluid.ReadModelPart(fixed_model_part) -print("fixed model read correctly") - -# NODAL CONDITIONS of the PFEM model -for node in pfem_model_part.Nodes: - node.SetSolutionStepValue(DENSITY, 0, pfem_nonewtonian_coupled_var_benchmark.Density) - node.SetSolutionStepValue(VISCOSITY, 0, pfem_nonewtonian_coupled_var_benchmark.Viscosity) - node.SetSolutionStepValue(POROSITY, 0, pfem_nonewtonian_coupled_var_benchmark.Porosity) - node.SetSolutionStepValue(DIAMETER, 0, pfem_nonewtonian_coupled_var_benchmark.Diameter) - node.SetSolutionStepValue(BODY_FORCE_X, 0, pfem_nonewtonian_coupled_var_benchmark.Gravity_X) - node.SetSolutionStepValue(BODY_FORCE_Y, 0, pfem_nonewtonian_coupled_var_benchmark.Gravity_Y) - node.SetSolutionStepValue(BODY_FORCE_Z, 0, pfem_nonewtonian_coupled_var_benchmark.Gravity_Z) - node.SetSolutionStepValue(YIELD_STRESS, 0, pfem_nonewtonian_coupled_var_benchmark.YieldStress) - - -edgebased_levelset_solver.AddDofs(fixed_model_part) - -# NODAL CONDITIONS of the FIXED model -# we assume here that all of the internal nodes are marked with a negative distance -# set the distance of all of the internal nodes to a small value -small_value = 0.0001 -n_active = 0 -for node in fixed_model_part.Nodes: - dist = node.GetSolutionStepValue(DISTANCE) - if(dist < 0.0): - n_active = n_active + 1 - node.SetSolutionStepValue(DISTANCE, 0, -small_value) - else: - node.SetSolutionStepValue(DISTANCE, 0, small_value) -if(n_active == 0): - raise "ERROR. At least one node has to be initialized with a distance lesser than 0" - -# make sure that the porosity is not zero on any node (set by default to fluid only) -for node in fixed_model_part.Nodes: - if(node.GetSolutionStepValue(POROSITY) == 0.0): - node.SetSolutionStepValue(POROSITY, 0, 1.0) - if(node.GetSolutionStepValue(DIAMETER) == 0.0): - node.SetSolutionStepValue(DIAMETER, 0, 1.0) - -# print pfem_model_part -# print pfem_model_part.Properties - -# setting the limits of the bounding box -box_corner1 = Vector(3); -box_corner1[0] = pfem_nonewtonian_coupled_var_benchmark.min_x; -box_corner1[1] = pfem_nonewtonian_coupled_var_benchmark.min_y; -box_corner1[2] = pfem_nonewtonian_coupled_var_benchmark.min_z; -box_corner2 = Vector(3); -box_corner2[0] = pfem_nonewtonian_coupled_var_benchmark.max_x; -box_corner2[1] = pfem_nonewtonian_coupled_var_benchmark.max_y; -box_corner2[2] = pfem_nonewtonian_coupled_var_benchmark.max_z; - -# time setting -output_dt = pfem_nonewtonian_coupled_var_benchmark.output_Dt -max_dt = pfem_nonewtonian_coupled_var_benchmark.max_dt -min_dt = pfem_nonewtonian_coupled_var_benchmark.min_dt -safety_factor = pfem_nonewtonian_coupled_var_benchmark.safety_factor -nsteps = pfem_nonewtonian_coupled_var_benchmark.nsteps - -# the buffer size should be set up here after the mesh is read for the first time -pfem_model_part.SetBufferSize(2) -fixed_model_part.SetBufferSize(2) - - -# constructing the fluid_solver (FIXED) -body_force = Vector(3) -body_force[0] = pfem_nonewtonian_coupled_var_benchmark.Gravity_X -body_force[1] = pfem_nonewtonian_coupled_var_benchmark.Gravity_Y -body_force[2] = pfem_nonewtonian_coupled_var_benchmark.Gravity_Z - -viscosity = edgebased_levelset_var.viscosity -# print "***************** VISCOSITY *********************" -# print viscosity -density = edgebased_levelset_var.density -# print "***************** DENSITY *********************" -# print density -fluid_solver = edgebased_levelset_solver.EdgeBasedLevelSetSolver(fixed_model_part, domain_size, body_force, viscosity, density) - -fluid_solver.redistance_frequency = edgebased_levelset_var.redistance_frequency -fluid_solver.extrapolation_layers = edgebased_levelset_var.extrapolation_layers -fluid_solver.stabdt_pressure_factor = edgebased_levelset_var.stabdt_pressure_factor -fluid_solver.stabdt_convection_factor = edgebased_levelset_var.stabdt_convection_factor -fluid_solver.tau2_factor = edgebased_levelset_var.tau2_factor -fluid_solver.edge_detection_angle = edgebased_levelset_var.edge_detection_angle -fluid_solver.assume_constant_pressure = edgebased_levelset_var.assume_constant_pressure - -fluid_solver.Initialize() - -if(edgebased_levelset_var.wall_law_y > 1e-10): - fluid_solver.fluid_solver.ActivateWallResistance(edgebased_levelset_var.wall_law_y); - -# - -if(SolverType == "pfem_solver_ale"): - # adding dofs - print("pfem_solver_ale is being used whereas with erosion module only monolithic solver lagrangian is allowed. Check also to be using use asgs2d!!") -elif(SolverType == "monolithic_solver_lagrangian"): - # adding dofs - monolithic_solver_lagrangian_nonnewtonian.AddDofs(pfem_model_part) - structural_solver = monolithic_solver_lagrangian_nonnewtonian.MonolithicSolver(pfem_model_part, domain_size, box_corner1, box_corner2) - oss_swith = pfem_nonewtonian_coupled_var_benchmark.use_oss - dynamic_tau = pfem_nonewtonian_coupled_var_benchmark.dynamic_tau - pfem_model_part.ProcessInfo.SetValue(OSS_SWITCH, oss_swith); - pfem_model_part.ProcessInfo.SetValue(DYNAMIC_TAU, dynamic_tau); - structural_solver.linear_solver = SuperLUSolver() -# structural_solver.conv_criteria = UPCriteria(1e-9,1e-9,1e-9,1e-9) - structural_solver.Initialize(output_dt) - - -if (domain_size == 3): - ProjectionModule = MeshTransfer3D(); - ErosionModule = ErosionUtils3D(); -else: - ProjectionModule = MeshTransfer2D(); - ErosionModule = ErosionUtils2D(); -PfemUtils = PfemUtils(); -DragUtils = DragUtils(); - -# To be inserted in the problem type######## -critical_vel = Vector(3); -critical_vel[0] = 0.06; -critical_vel[1] = 0.0; -critical_vel[2] = 0.0; -critical_en = 0.000001; -# - -ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, POROSITY, POROSITY); -ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, DIAMETER, DIAMETER); -for node in fixed_model_part.Nodes: - if(node.GetSolutionStepValue(POROSITY) == 0.0): - node.SetSolutionStepValue(POROSITY, 0, 1.0) - if(node.GetSolutionStepValue(DIAMETER) == 0.0): - node.SetSolutionStepValue(DIAMETER, 0, 1.0) - - -# bool to decide to solve or not the pfem model -calculate_dam = True - -# settings to be changed edgebased FIXED -max_Dt = edgebased_levelset_var.max_time_step -initial_Dt_ls = 0.001 * max_Dt -final_time = edgebased_levelset_var.max_time -safety_factor = edgebased_levelset_var.safety_factor -number_of_inital_steps = edgebased_levelset_var.number_of_inital_steps -initial_time_step = edgebased_levelset_var.initial_time_step -out = 0 - -original_max_dt = max_Dt -Time = 0.0 -step = 0 -next_output_time = output_dt -max_safety_factor = safety_factor - -substep_number = 10 -substep_counter = 0 -# -# back_node = NodeFinder(pfem_model_part.Nodes , 0.34001, 0.381552, 0.0) -back_node = NodeFinder(fixed_model_part.Nodes, 0.2669, 0.2355, 0.0) -print(back_node) - -# -while(Time < final_time): -# print "line49" - - if(step < number_of_inital_steps): - max_Dt = initial_time_step - else: - max_Dt = original_max_dt - # progressively increment the safety factor - # in the steps that follow a reduction of it - safety_factor = safety_factor * 1.2 - if(safety_factor > max_safety_factor): - safety_factor = max_safety_factor - - Dt = fluid_solver.EstimateTimeStep(safety_factor, max_Dt) - - Time = Time + Dt - fixed_model_part.CloneTimeStep(Time) - - # let's do this later ... only each substep_number fluid solutions - # pfem_model_part.CloneTimeStep(Time) - - print("******** CURRENT TIME = ", Time) - - if(step > 3): - if(calculate_dam): - # (origin_model_part, destination_model_part, origin_variable_destination_variable) - ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, POROSITY, POROSITY); - ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, DIAMETER, DIAMETER); - - for node in fixed_model_part.Nodes: - if(node.GetSolutionStepValue(POROSITY) == 0.0): - node.SetSolutionStepValue(POROSITY, 0, 1.0) - if(node.GetSolutionStepValue(DIAMETER) == 0.0): - node.SetSolutionStepValue(DIAMETER, 0, 1.0) - - # solving the fluid problem ........................................................................................... - print("starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~") - fluid_solver.Solve(); - print("finished solving fluid edgebased") - if(Time < 2.4): - BenchmarkCheck(Time, back_node) - - print("start checking the time stepping") - check_dt = fluid_solver.EstimateTimeStep(0.95, max_Dt) - - if(check_dt < Dt): - print("***********************************************************") - print("***********************************************************") - print("***********************************************************") - print(" *** REDUCING THE TIME STEP ***") - print("***********************************************************") - print("***********************************************************") - print("***********************************************************") - - # we found a velocity too large! we need to reduce the time step - fluid_solver.fluid_solver.ReduceTimeStep(fixed_model_part, Time) # this is to set the database to the value at the beginning of the step - - safety_factor *= edgebased_levelset_var.reduction_on_failure - reduced_dt = fluid_solver.EstimateTimeStep(safety_factor, max_Dt) - - print("time before reduction= ", Time) - Time = Time - Dt + reduced_dt - print("reduced time = ", Time) - print("Dt = ", Dt) - print("reduced_dt = ", reduced_dt) - - fluid_solver.fluid_solver.ReduceTimeStep(fixed_model_part, Time) # this is to set the database to the value at the beginning of the step - fluid_solver.Solve() - - print("finished checking the time stepping") - print(fixed_model_part) - - if(substep_counter == substep_number): - substep_counter = 0 - - pfem_model_part.CloneTimeStep(Time) - - print(pfem_model_part) - # solving the structural problem ........................................................................................... - print("starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~") - PfemUtils.CalculateNodalMass(pfem_model_part, domain_size) -# COMMENTING OUT provisionally BEGIN -# print "starting EROSION" -# structural_solver.neigh_finder.Execute(); -# print "founded neighbours" -# calculate_dam = ErosionModule.CheckErosionableNodes(fixed_model_part, pfem_model_part, critical_vel, critical_en, viscosity, density); -# print "finished EROSION" -# COMMENTING OUT provisionally END - - if(calculate_dam): - # Projecting the water pressure - ProjectionModule.DirectScalarVarInterpolation(fixed_model_part, pfem_model_part, PRESSURE, WATER_PRESSURE); - -# COMMENTING OUT provisionally BEGIN - # Adding Darcy non linear term to the external forces -# DragUtils.CalculateFluidDrag(fixed_model_part, SEEPAGE_DRAG, viscosity) -# ProjectionModule.DirectVectorialVarInterpolation(fixed_model_part, pfem_model_part, SEEPAGE_DRAG, SEEPAGE_DRAG); -# DragUtils.AddDrag(pfem_model_part, SEEPAGE_DRAG, BODY_FORCE, body_force) -# COMMENTING OUT provisionally END - - # PFEM steps - structural_solver.Remesh(); - print("Remesh in done!") - (structural_solver.solver).Solve(); -# BenchmarkCheck(Time, back_node) - - print("Solve in done!") - (structural_solver.solver).Clear(); - - print("finished solving structure") - # ErosionModule.SetErosionableNodes(pfem_model_part); - # if (Time>0.25): - # ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, POROSITY); - # for node in fixed_model_part.Nodes: - # if( node.GetSolutionStepValue(POROSITY) == 0.5): - # print node.Id - - if (Time > 9.0): - substep_number = 2 - substep_counter += 1 - -# - if(Time >= next_output_time): - # a change in the output name is needed!!!! - - res_name1 = str(name_fixed) - gid_io.ChangeOutputName(res_name1) - gid_io.InitializeMesh(Time); - gid_io.WriteMesh(fixed_model_part.GetMesh()) - gid_io.FinalizeMesh(); - gid_io.InitializeResults(Time, fixed_model_part.GetMesh()) -# print "structure output ****************************************************" - gid_io.WriteNodalResults(VELOCITY, fixed_model_part.Nodes, Time, 0) -# gid_io.WriteNodalResults(CONV_VELOCITY,fixed_model_part.Nodes,Time,0) - gid_io.WriteNodalResults(PRESSURE, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DISTANCE, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(PRESS_PROJ, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(POROSITY, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DIAMETER, fixed_model_part.Nodes, Time, 0) -# gid_io.WriteNodalResults(SEEPAGE_DRAG,fixed_model_part.Nodes,Time,0) - - gid_io.Flush() - gid_io.FinalizeResults() - - res_name2 = str(name_pfem) - gid_io.ChangeOutputName(res_name2) - gid_io.InitializeMesh(Time); - gid_io.WriteNodeMesh(pfem_model_part.GetMesh()); - gid_io.WriteMesh(pfem_model_part.GetMesh()) - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(Time, pfem_model_part.GetMesh()) -# print "fluid output ****************************************************" - gid_io.WriteNodalResults(VELOCITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(PRESSURE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_FREE_SURFACE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_BOUNDARY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_STRUCTURE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(VISCOSITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DENSITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(BODY_FORCE, pfem_model_part.Nodes, Time, 0) -# gid_io.WriteNodalResults(FRICTION_COEFFICIENT,pfem_model_part.Nodes,Time,0) -# gid_io.WriteNodalResults(IS_EROSIONABLE,pfem_model_part.Nodes,Time,0) - gid_io.WriteNodalResults(POROSITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DIAMETER, pfem_model_part.Nodes, Time, 0) -# gid_io.WriteNodalResults(SEEPAGE_DRAG,pfem_model_part.Nodes,Time,0) - gid_io.WriteNodalResults(WATER_PRESSURE, pfem_model_part.Nodes, Time, 0) - gid_io.PrintOnGaussPoints(TEMPERATURE, pfem_model_part, Time) - gid_io.PrintOnGaussPoints(AUX_INDEX, pfem_model_part, Time) - - gid_io.Flush() - gid_io.FinalizeResults() - - next_output_time = Time + output_dt - - out = 0 - - out = out + 1 - step = step + 1 - print("step finished") - -print("solution finished") diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope_benchmark.py b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope_benchmark.py deleted file mode 100644 index d7850512e7b5..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope_benchmark.py +++ /dev/null @@ -1,22 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import sys -kratos_benchmarking_path = '../../../../benchmarking' -sys.path.append(kratos_benchmarking_path) -import benchmarking - -Text = " " - -# -print("verifying CoupledNonNewtSlope.py...") -successful,Msg = benchmarking.RunBenchmark("CoupledNonNewtSlope.py", "CoupledNonNewtSlope_ref.txt") - -if(successful==True): - Text += "OK\n" - print("CoupledNonNewtSlope example SUCCESFUL") -else: - Text += "FAILED\n" - Text += Msg - Text += "\n\n" - print("CoupledNonNewtSlope example FAILED") - -print(Text) diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope_build_reference.py b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope_build_reference.py deleted file mode 100644 index b682bb933aca..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope_build_reference.py +++ /dev/null @@ -1,8 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import sys -kratos_benchmarking_path = '../../../../benchmarking' -sys.path.append(kratos_benchmarking_path) -import benchmarking - -print("Building reference data for CoupledNonNewtSlope.py...") -benchmarking.BuildReferenceData("CoupledNonNewtSlope.py", "CoupledNonNewtSlope_ref.txt") diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope_ref.txt b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope_ref.txt deleted file mode 100644 index 1b65752fc315..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/CoupledNonNewtSlope_ref.txt +++ /dev/null @@ -1,7215 +0,0 @@ -KRATOS_BENCHMARK | Float | Time | 5e-05 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 6e-05 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -9.67431430786e-06 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 7e-05 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 3.20786154562e-05 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 8e-05 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.00012322606986 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 9e-05 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.000261755391594 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.000446583550364 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0006739379344 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0261360779961 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0541896343104 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0761858220526 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0809473333394 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0669848820674 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0419265803927 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0149489877466 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.00794957426446 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.02469184211 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0337563727951 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0330777106295 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0238239126769 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.00867995965835 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0127484195888 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0384560409852 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0607176451743 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0703721291023 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0640649591911 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0457374725473 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0227416410962 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.00133123560615 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0151069535979 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0257797395635 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0300691307595 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.028327089233 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0212433370434 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.00713714618518 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0139155323547 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.037643723853 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0560065752215 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0619884911204 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.00935814651645 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.00204214132695 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0118875892912 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0156092351441 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0189670494579 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0218600329982 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0239486026996 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | -0.0043565571714 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0098427587235 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.02878262462 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0327486908123 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.051489902023 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0450730918276 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0373101384023 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0298783472831 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0239665817093 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0202179106423 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.035136742635 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.03458466185 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0361233681593 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.038725016059 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0410321545311 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0411438591738 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0416657283546 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0403630694492 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0381087252295 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0359163080866 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0346342694581 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0348303258056 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.036580805335 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0395495548754 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0430193940578 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0460839009961 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0480242011828 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0484614886286 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0475852153173 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0459829748199 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0443854206746 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0434754520497 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0437841552399 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0454564800258 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0480191558225 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0509265167686 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0535515827512 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0553290236311 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0559911674305 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0556612051784 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0552333135963 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.171723150291 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.153341091018 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.140126900699 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.130331481516 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123038392617 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.117577587936 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.113247979032 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0652180134891 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634188001466 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0618371402551 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0603512800842 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0590087220212 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0579791379186 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0574132199719 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0113769320414 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0106691723285 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0106525652866 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0109137032633 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.0991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0110932480523 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0110243246478 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0110898313987 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0109159050205 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0106512841043 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0104690225726 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0105023973867 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0594690312841 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0596881024142 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0607336508851 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0620594549877 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0633606588814 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0645476679113 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0654878213613 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0661889032827 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0667610561024 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0673292204228 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0680271121091 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0688980061456 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0699406040589 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0711032639824 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0722982260391 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0734499986076 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0744659909687 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0753086278723 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0759922902869 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0764611228491 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0768477174858 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0773533547183 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0779911011064 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0787242989057 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0795078373899 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.080284937256 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0809968316826 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0816048088011 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0821004738052 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0825102155242 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0828810767133 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0832649777156 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0837024322679 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0842114436913 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0847830318263 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0853856081945 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0859789177247 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0865249776868 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870015471393 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0874086920966 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0877646013195 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0881011638131 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0884495912954 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0888322126555 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0892555720861 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0897083441945 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0906342269167 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0919178651743 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0931408881051 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0942306676584 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0950851582222 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0957444870834 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0963096703342 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0968587263508 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0974415367886 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0412349509856 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0394563558981 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106750782028 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106492696498 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105808068799 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103494907741 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101389610756 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0997375930655 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985648989751 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0978054284735 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0973765824421 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0971718529962 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0969628005989 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0968241720234 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0967518198745 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0967736763025 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 0.0 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0968703096344 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11557.1395649 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0970358151044 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -12510.9398986 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0995260233096 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -12208.9766671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0929190983302 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11783.0673917 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0872385314984 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11585.2845816 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0824405411781 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11569.9683229 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0785123409575 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11643.9965875 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0753776862756 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11737.2127092 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0728997830625 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11775.7660159 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0709595712028 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11753.4328521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0693699289449 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11679.1373694 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0680156162722 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11504.8633318 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0668578340618 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11282.6985832 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0658516014731 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11123.8276676 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0649668501693 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -11030.8922861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0641773130328 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10980.5974881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0635094564699 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10950.3334414 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.062990245289 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10937.1155574 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0626252700875 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10901.1029887 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.062438079021 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10850.4302579 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.062368378738 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10787.6493303 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0623876186543 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.1991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10717.405784 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0624733154621 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10660.8657188 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0626096105571 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10591.9799253 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0628212346566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10524.3698803 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0630661406891 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10459.0864572 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0633364442433 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10395.0227307 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0636277110019 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10356.2180914 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0639707180612 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10291.0744277 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0643505890195 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10221.1294179 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0647172054566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10151.1276662 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0650855744192 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10081.8046273 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0654605162109 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -10030.2596602 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0658426011635 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9965.31106187 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0662640979457 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9900.00560033 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0666895700824 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9835.1800991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0671146228462 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9770.66137108 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0675372736911 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9725.19557142 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0679563353814 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9662.35046945 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.068404749438 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9597.01656779 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0688472229653 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9530.53783906 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0692808666431 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9463.48489141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0697057387979 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9420.61677556 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0701229998695 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9356.42427357 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0705708852109 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9290.71912087 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0710127179753 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9224.99363069 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0714465098881 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9159.46423866 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0718724303616 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9115.32173438 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0722908637655 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -9051.97576342 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0727344547485 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8986.72629331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0731699385803 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8920.79418268 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0735950212927 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8854.55471018 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0740099583546 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8808.83320672 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0744158324574 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8744.61099189 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0748440667404 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8679.05338471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0752647468646 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8594.89723259 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0755421717 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8497.0597109 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0758206557453 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8455.86423768 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0760754617837 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8396.78276092 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0763988365208 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8338.17527192 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0767616451195 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8279.62942172 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.077150508567 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8219.86469283 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.077550818446 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8178.85967165 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0779498850869 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8117.14062222 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0783656306864 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -8052.50050745 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.078766428497 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7986.58333083 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0791498460137 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7920.1429645 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0795177223507 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7874.24362763 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0798732984414 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7809.52304368 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0802447101636 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7743.70739439 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0806082428936 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7677.83996702 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0809635607727 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7612.13218502 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0813112232456 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7567.84922541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0816516840114 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7504.0929347 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.082009012792 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7368.78934162 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0825090570433 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7180.24444871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0828812429363 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7085.02556842 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0831794221634 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7053.30782738 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0834438939504 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7023.26597657 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0837175935186 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6996.33536983 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0839963318339 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6961.71336337 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.084284468324 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6914.90881749 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0845814064091 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6878.06890467 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0848847532196 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6812.96403892 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0852076656881 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6743.50357988 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0855316496891 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6679.29859198 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0858949184751 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6610.39071503 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0862284387588 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6565.07654768 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0865445928922 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6502.19845851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0868751301337 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6440.03902952 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0872069170734 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6107.06287987 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.064897654283 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -6027.450811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0631204724733 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5927.94169282 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0616127448907 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5859.47952632 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.060381838077 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5810.56683186 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0594334586196 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5769.26910534 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0587330150081 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5726.14917917 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0582267974189 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5677.26594075 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0578580843166 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5619.16566269 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0575765535024 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5554.60468326 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0573502727119 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5486.40516807 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0571596345645 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5417.38500861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0569970691211 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5350.73501929 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0568625074192 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5285.1351025 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0567565468973 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5221.77727541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0566844694542 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5146.80249175 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0566618373695 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5067.00645437 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0566761794983 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -5001.62511265 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0567077906376 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4942.18533415 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0567515294502 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4885.50012295 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0568096413356 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4829.46843502 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0568804477536 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4772.86838434 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.056963076301 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4626.9681651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0565857816941 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4544.87026004 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.056163729331 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4477.14300157 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0558309475412 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4418.7475123 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0556328376531 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4365.51525473 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0555571679267 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4314.72886588 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0555720695133 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4261.26475867 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0556438565451 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4205.24225341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0557393127867 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4146.71738393 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0558373725146 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.2991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4086.48600019 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0559274119425 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -4026.42171642 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0560073597161 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3965.66424683 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.056082688264 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3905.54951346 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0561567250629 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3846.29528061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0562349832554 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3787.78639262 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0563210433056 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3730.62764138 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0564160173587 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3672.86379621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0565208657662 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3615.09738791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0566308558631 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3557.21261151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.056743359344 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3499.18475698 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0568561589758 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3441.82486771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0569676630643 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3383.61131612 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0570790418468 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3325.40556114 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0571883370077 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -3267.25217682 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0572961266222 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -2160.40849079 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0871639138936 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -2110.2421566 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0830632227224 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -2088.83729041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0797906599139 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -2072.7496586 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0773119701781 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -2051.20463124 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.075365631416 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -2021.0073509 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0737479000175 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1976.80016671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.072333511807 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1936.15155449 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0710636762519 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1895.39432852 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0699206295729 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1856.59712205 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0689065832235 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1820.50876327 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0680276933692 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1778.9134506 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0672847823846 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1746.66463724 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0666708545585 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1714.94483846 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0661730171611 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1683.05570619 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0657755039175 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1650.6926302 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0654637559778 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1609.77859353 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0652759164499 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1576.00765295 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0651085228875 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1542.54342415 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0649767918514 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1509.20327819 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0649078775002 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1476.16182689 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0649000407297 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1435.89534614 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0649466278208 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1403.21635888 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0650395300913 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1370.56420025 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0651715403168 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1337.86547894 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.065335660644 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1305.10584558 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0655264906756 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1265.5488924 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0657402045791 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1232.77393011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0659742259776 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1200.01766959 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0662274869334 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1167.27958279 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0664987066793 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1134.56667229 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0667869301879 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1095.92891794 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0670911503131 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1063.31801561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.067410140561 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1030.7570222 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0677429537195 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -998.208864711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0680878353236 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -965.666130132 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0684432034119 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -928.027786137 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0688076450412 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -895.544358125 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0691801926934 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -863.068076449 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0695598898362 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -830.585913553 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0699456840773 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -798.098944316 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0703368443702 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -881.587788554 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0710851183456 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -836.489439977 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.074484915814 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -792.094601028 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0775406376676 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -740.035606801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0802446923222 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -692.951178249 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0824490743508 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -654.049941377 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0843391136789 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -622.827859238 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0860453448674 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -592.625828641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0876357229376 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -561.294489043 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0891371701172 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -527.922477721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0905469541426 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -490.681620053 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0918504050822 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -453.939961373 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0930391104612 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -416.420872006 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0941046843822 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -378.709687173 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.09505296814 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -341.141510607 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0958975965129 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -297.769787564 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0963686719027 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -260.380106815 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0964731828955 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -223.942443276 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0965661964141 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -188.125463158 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0967346526034 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -152.452697935 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0970012409718 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -116.257561402 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0973493503032 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -80.2933263077 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0977489177211 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -44.1607511264 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981609581444 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7.95211589726 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985579272148 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1439.7652422 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0939897501433 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -2146.12833066 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0904829821602 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1983.59991363 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0873231251058 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1812.11873503 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0845248644581 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1653.07018753 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0821432553005 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1523.76345726 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.080169784441 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1432.78021345 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0785678196553 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1367.18782988 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0772384446574 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1321.55146707 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0761013761386 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1286.87026718 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0750928057478 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1255.61492847 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.074171286664 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1226.61343066 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0733285324307 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1191.35384956 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0725476526325 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1152.83378167 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0718314875022 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1112.33200994 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0711858427924 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1071.59826527 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0706143510851 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -1035.08904346 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.070125218187 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -997.594976148 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0697041997754 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -961.717755049 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0693428325663 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -927.345141271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0690322087436 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.3991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -894.018901479 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0687641232618 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -864.389886277 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0685395179729 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -856.450971822 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0683382556599 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -829.02546494 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0681310777436 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -777.823238807 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0679219677596 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -733.604058174 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.067737407019 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -701.084757984 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.067597733929 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -670.218868659 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0674991835115 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -633.545005492 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0674692743324 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -616.015765403 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0674518485163 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -588.74031607 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0674423898752 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -559.728405061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0674559936518 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -527.523071081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0674874949658 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -495.276726974 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0675334880754 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -463.466112894 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0675898020176 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -432.192897858 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0676526266477 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -404.515041872 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0677249475266 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -374.419010604 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0677989095486 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -344.212183448 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0678734874266 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -313.985564436 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0679488951571 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -283.719818157 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0680258787378 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -256.669438574 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0681108286041 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -226.759981709 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0681984169963 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -196.565184254 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0682884566547 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -166.307281946 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0683808143454 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -136.047656356 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0684751900265 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -109.160288479 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0685764619766 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -79.3616183402 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0686786027012 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -49.2868802848 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0687809449228 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | -19.117783564 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0688833647522 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11.092285155 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0689858872744 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 37.8909631582 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0690935979535 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 67.7150788878 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0692012138993 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 97.8241751716 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0693084452208 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 128.017947785 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0694153302552 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 158.245839611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0695219354442 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 184.972586975 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0696330281313 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 214.79917623 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0697435168709 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 244.912971781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0698531704132 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 275.106890993 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0699620804725 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 305.327308995 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0700703879454 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 331.957257685 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0701826789307 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 361.74032972 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.070294110621 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 391.785175145 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0704044630831 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 421.887198692 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0705137513114 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 452.014972138 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0706220605746 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 403.894211895 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0702106238334 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 349.10943586 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0690246120606 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 355.753190067 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.067890651154 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 402.57686321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0669226771734 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 466.886839985 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0661854130353 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 529.20524332 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.065682949004 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 583.358803757 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0653707458011 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 588.005552349 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0649808361142 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 627.11164238 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0646176585839 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 659.384184097 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.064301587664 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 685.913259138 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0640590994652 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 710.389628543 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0638747859824 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 734.939306316 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0637388523968 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 760.117176136 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0636415479572 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 785.84436952 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0635734651627 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 810.349358729 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0635290193882 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 836.274439611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.063498273159 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 862.247924695 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634761505401 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 888.234998458 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634596178783 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 914.316990033 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634473883051 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 939.209083423 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634421875486 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 965.603911112 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634415639721 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 992.399132508 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634461914615 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1019.4817964 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634565602996 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1046.74448598 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634727075691 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1072.78018498 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0634968833202 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1099.98814363 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0635253786389 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1127.2893226 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0635573051163 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1154.61984175 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0635919190214 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1181.96649335 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0636286442658 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1208.07638555 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.063669555143 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1235.3132592 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0637116285646 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1262.65741233 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.063754670176 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1290.04459573 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0637985894438 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1317.44251129 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0638433034005 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1343.63864196 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0638910040341 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1370.89906417 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0639390399896 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1398.25329739 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0639873375103 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1425.66777684 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0640359081525 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1453.12986606 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0640847842904 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1479.48267579 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0641361005221 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1506.87860777 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0641874681182 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1534.34620084 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0642388413739 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1561.82765113 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0642901818678 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1589.2921187 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0643414290398 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1615.63718768 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.064394460724 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1642.93656559 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0644470258238 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1670.28376204 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0644991239758 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1697.66255635 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0645508243402 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1725.06901573 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0646022144323 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1751.46389244 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0646551497195 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1778.81009693 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0647076533434 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1806.21048908 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0647597589871 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1833.62703714 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0648114904023 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.4991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1861.03596823 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0648628456133 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1894.74548378 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.064956613542 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1883.18449816 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0650019947817 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1872.66699621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0650000344612 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1921.97731163 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0650181544325 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1959.28448831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0650582673791 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1995.55140867 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0651214677146 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2030.07969817 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0651994357573 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2061.23487746 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0652843751628 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2089.04583299 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0653694357993 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2114.38473829 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0654501633458 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2137.77197711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0655262847572 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2161.62449138 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0655960940082 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2186.254845 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0656609722873 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2211.97671412 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0657226210677 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2238.69809795 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0657823531312 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2265.50631504 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0658423834898 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2293.10594213 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0659013838671 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2320.75481258 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.065959479495 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2348.17224446 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0660165929588 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2375.27288764 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0660727120931 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2401.53997135 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0661291181597 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2428.04448729 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0661844031075 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2454.52095123 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.066238713023 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2359.71821695 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0663774204536 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2062.374344 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0666163217596 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2129.47516602 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0669222160988 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2253.64736728 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0672619485708 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2362.3874731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0675810174343 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2440.87178195 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0678443497661 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2492.98887726 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0680374758188 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2317.32439741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0693168813913 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1984.99737198 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0705670328808 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2039.32332104 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0715403578718 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2082.66652616 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0723615486891 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2152.51482164 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0731202909773 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2238.06579974 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0738660607097 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2321.63541817 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.074613768109 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2391.11400011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0753529856431 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2440.8994819 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0760619156639 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2471.74881549 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0767188426784 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2488.77974896 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0773095924556 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2498.31357014 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0778304881865 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2506.3614604 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0782867468508 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2517.10881278 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0786895268277 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2532.33459877 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.079051746206 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2291.96397493 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0788498877138 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1786.75912221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0779538555931 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1843.52224216 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0774250166846 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2073.77460233 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.077341848238 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2299.68880135 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0776269356628 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2472.2785342 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0781525806416 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2586.24603876 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0787957084301 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2653.98150048 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0794655617448 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2691.85181229 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0801089614676 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2713.51695742 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0807030097158 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2729.97893673 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0812471111402 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2744.84806633 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0817487530924 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2761.19970259 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0822188909141 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2778.97211977 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0826659491752 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2779.92527475 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0830956062459 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2786.71837959 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0835069404526 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2778.01456276 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0837279998716 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2769.92420217 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0838145840582 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2783.64156156 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0838886922619 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2801.5218317 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0839881987529 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2821.537208 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0841247854225 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2839.3068416 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0842910771293 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2855.03158446 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0844746777528 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2868.88580606 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0846624340456 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2881.44034531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0848435833041 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2894.55840205 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0850136970278 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2906.59200476 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0851678339992 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2918.73070959 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0853057356868 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2931.26501128 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0854295059965 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2944.21093254 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.085542093267 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2958.46280724 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0856487700241 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2971.89805468 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0857493895027 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2985.00688133 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0858444335357 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2997.82065036 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0859339799769 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3010.37525542 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0860177398937 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3023.58975959 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0860979241945 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3036.00731203 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0861720324508 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3048.20420142 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.086239509688 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3060.40105786 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0863004889624 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3072.70784873 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0863554474104 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3085.79485986 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0864077581355 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3098.51715335 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0864556290573 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3111.08686146 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0864989733098 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3123.59450973 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0865379703612 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3136.07256506 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.08657282341 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3149.02030029 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866064354363 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3161.6304405 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866366406153 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3174.0329944 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866631067521 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3186.37362657 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866859149451 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3198.72653818 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867053009822 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3211.44434995 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867241735411 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3224.02890273 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867405170899 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3236.43366706 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867540459247 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3248.76808241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867647872421 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.5991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3261.08669199 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867728674255 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3273.63665314 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867811554252 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3286.15050537 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867874686915 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3298.49825158 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867914927008 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3310.79775755 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867932599478 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3323.11001944 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867929275092 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3335.52800858 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867933205633 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3367.12867495 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0868722471719 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3373.25178241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.086937875007 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3375.43281899 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0869616909181 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3386.6888727 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0869707268287 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3401.21826005 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0869790053716 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3416.95598251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0869890943036 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3432.26841572 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870016339592 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3446.55674713 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870153923308 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3459.69042316 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870284209778 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3471.77617783 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870412204493 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3483.41901346 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870504925651 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3494.62671634 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870553145176 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3505.75879582 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870555813035 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3266.75509093 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0873230621255 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3406.79374466 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0878246618096 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3437.23817537 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0881390032219 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3390.78205278 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0882534129569 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3346.44240919 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0882145990074 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3327.54842112 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0880859703811 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3333.34794384 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0879269192546 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3357.23813394 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0877707027085 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3387.57654643 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0876324506488 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3416.91387264 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0875123406335 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3441.69053813 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0874028453202 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3459.72580029 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0872977001303 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3476.21681204 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0871886251136 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3491.72698051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870739991105 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3508.13445677 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0869564774763 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3526.42831894 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0868410108066 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3450.56258454 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0868074113576 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3389.27972253 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867759964506 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3415.64694423 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867274413695 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3444.72780309 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866841839793 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3489.04929244 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.086654432335 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3536.5075481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866446413885 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3580.87931604 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866542450966 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3615.14786671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866803939031 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3637.93248789 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867181515266 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3651.26203119 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867623694773 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3657.52299114 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0868102934512 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3663.96540525 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0868586035147 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3671.88965199 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0869061440393 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3683.37723388 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0869537620873 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3698.65251538 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870028235654 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3715.58532678 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.087056245025 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3735.30449971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.087113082184 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3755.31133148 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0871731191554 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3774.56711759 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0872357161638 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3792.57073768 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0872999833277 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3808.01308065 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0873665047976 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3823.65235003 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0874329041912 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3838.78826303 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0874983992532 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3853.80188864 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0875625954207 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3868.99077763 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0876254312276 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3883.22637782 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0876884662777 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3898.94588064 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0877504989321 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3914.90366216 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0878116480349 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3852.03751564 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0876831594894 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3826.54687133 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0872908822415 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3828.90304309 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0868996777136 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3845.85354262 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0865636260883 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3821.23060773 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0861584385957 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3846.77418637 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0857933487763 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3890.50277414 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0855421819354 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3933.03232173 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0854156534771 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3965.73169693 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0853822071817 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3989.19459109 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0854078722781 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4004.66548801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0854609252406 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4014.73336459 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0855176711392 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4021.58706326 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0855657229639 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4029.42991029 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0855998017282 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3984.23390102 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0856330083861 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3971.35243353 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0856511941501 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3997.2022134 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0856637830204 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4026.42797318 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.085683167395 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4057.69251384 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0857133334552 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4087.05152944 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0857544369051 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4112.17561383 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0858040090222 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4132.21533369 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0858586819118 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4146.9454401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0859163790401 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4159.14903941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0859735422161 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4169.93128706 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0860285292928 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4180.89570293 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0860807732662 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4193.08389239 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.086130318525 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4206.26297109 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0861787949572 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4221.55042478 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0862256553842 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4237.85729346 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0862713532853 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4254.57435987 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0863163298319 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4271.14285201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0863608904059 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4286.54208595 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0864063248188 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4301.86207579 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0864515346663 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4316.55506427 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.086496362868 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4330.78517687 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0865406812789 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.6991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4344.77130042 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0865843770769 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4358.07406949 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866284361595 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4372.09712731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0866717915 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4386.34203071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867144491909 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4400.81378742 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.086756557612 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4415.44909533 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0867982873625 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4429.5141928 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.08684078904 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4444.13663053 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.086883108583 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4458.67984665 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0869252108111 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4473.11701868 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0869670922933 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4487.45683186 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870087456345 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4501.18269611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870510842384 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4515.40887342 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0870931738964 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4529.68159721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0871349860305 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4544.02599635 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0871765690365 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4558.43571771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0872179796573 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4572.39841693 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.087260084454 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4586.80273823 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0873020250542 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4601.17661568 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0873437249219 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4615.50321502 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.087385156066 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4629.78172054 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0874263119361 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4643.57805311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0874679835778 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4657.7871279 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0875093978286 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4672.02579268 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0875505576464 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4686.31359443 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0875915176957 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4700.64987259 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0876323300507 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4714.583695 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0876737544263 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4728.92645082 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0877150179181 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4743.25640778 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0877560552346 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4757.55980557 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0877968373825 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4771.83133475 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0878373524512 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4799.18443026 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0879187246599 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4810.03781244 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0879930631435 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4819.05307738 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0880495518278 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4832.87022403 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0880993276289 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4847.91693861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0881468115559 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4862.88859335 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0881948353805 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4878.04408059 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0882431775798 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4892.8585774 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0882916306934 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4907.29953878 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0883396726957 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4921.43035569 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0883867497731 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4934.99757203 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.088433198752 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4948.81255636 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0884779738401 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4962.66354287 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0885210653944 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4976.62774681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0885626771846 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4990.7283098 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0886031024217 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5004.59390786 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0886433776564 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5018.85827827 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0886829347844 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5033.15340684 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0887219107258 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5047.44535084 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0887604103591 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5061.70988643 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0887984955994 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5075.58660111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0888368895279 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5089.76813307 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0888748861189 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5081.3594513 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0889147597613 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5079.12326832 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0889517180409 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5095.60330988 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0889862646117 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5114.84730913 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0890228983181 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5133.07477358 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0890634940862 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5150.18484908 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0891084916751 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5166.192727 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.089157130048 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5181.20116036 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0892082557347 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5195.19945262 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0892613704151 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5073.50640137 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0896217998601 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4864.17187183 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0904472038182 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4951.15068796 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0911683302737 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5067.61879104 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0916930084808 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5165.8525473 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0920127792307 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5230.80024996 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.092160933094 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5268.2258318 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0921797252568 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5286.89646526 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0921120407002 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5295.90997025 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0919955105362 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5302.60536445 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0918595495216 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5311.05899644 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0917242677355 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5322.96804928 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0916011260511 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5337.92489463 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0914944110726 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5354.61521854 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.091403590543 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5371.67317058 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0913256537888 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5387.66917753 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0912570459284 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5402.27553141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0911951094296 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5415.56812814 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0911385957673 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5427.96311797 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0910875656334 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5440.11706123 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0910429122698 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5452.12877066 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0910056535258 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5464.40771876 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0909765554165 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5476.97089561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0909558079598 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5412.55771868 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0910981078514 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5076.79269902 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0913290266566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4987.83834352 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0915628260271 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4983.12490426 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0918182064899 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4940.66632528 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0920120158923 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4813.34000041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0918676056494 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4833.31660389 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0916917199776 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4920.73510005 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0915765579329 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5022.32948585 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0915594532398 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5110.75308 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0916371074097 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5172.46447358 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0917827226843 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5204.17520316 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.091960378187 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5213.08661839 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.092139364051 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5207.3918244 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0922985031611 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5196.40368918 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0924283508715 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.7991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5187.47467176 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0925296497737 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5184.87885022 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0926100204906 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5189.60835202 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.092678180766 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5200.69637631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.092742490129 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5215.80707233 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0928083727501 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5232.35232402 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.092877798313 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5248.21638752 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0929503055153 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5262.19178067 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0930229643599 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5273.84778961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0930928433387 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5283.55912748 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0931576449612 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5292.07496557 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0932162725987 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5300.16418141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0932692882778 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5308.5820667 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0933173421339 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5317.60626279 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.093361912563 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5327.36402894 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0934044697404 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5337.76365241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0934461502386 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5348.60382187 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0934879817512 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5359.60553392 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0935297579862 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5352.16975522 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0935282292606 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5349.43626758 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0934839908259 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5355.19382992 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0934346090691 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5369.72342982 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0934016031472 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5386.48259847 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0933922788421 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5236.71159531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0935998047515 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5111.27034923 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0939588062861 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5121.44679999 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0943134081814 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5157.65508512 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0946111872022 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5215.06344582 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0948309594554 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5277.31000547 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0949763881336 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5331.58725208 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0950645878252 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5370.58182496 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0951169232204 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5392.53819027 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0951534436654 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5400.35893259 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.095188180893 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5399.40776404 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0952297376377 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5395.05749871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0952809336223 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5392.22111806 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0953411402216 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5393.82198072 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.095408155675 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5400.29224197 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0954775773668 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5411.32242451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0955464644345 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5425.32300527 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.095612685375 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5440.47775155 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0956751451785 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5455.27577574 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0957340487149 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5468.76427999 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0957894274794 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5480.57559732 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0958418394324 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5490.86236219 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0958918523959 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5500.07673118 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0959398739361 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5508.73351218 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0959864877687 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5517.36632325 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0960314691847 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5526.23910405 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0960747993539 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5535.51151681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0961165449823 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5545.18725177 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.096156908714 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5555.09537953 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0961964592023 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5565.19600347 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0962351938448 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5575.26132714 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0962732727731 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5585.21564353 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0963108190351 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5595.02556203 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0963478794591 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5604.61087074 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0963847465361 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5614.20536734 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0964211053893 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5623.74024308 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0964568366404 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5633.28217679 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0964918816445 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5642.85901438 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0965262330182 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5652.3438246 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0965602693087 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5661.99844457 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0965938297668 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5671.62894521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0966269659762 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5681.22714128 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0966597287922 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5690.78845769 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0966921608394 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5700.128932 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0967245822198 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5709.63996603 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0967567588782 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5719.12556887 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0967886389615 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5555.50226397 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0968902452686 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5375.96998725 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.09693322582 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5391.77699318 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0969280339695 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5440.71721462 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0969091549072 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5537.34733613 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0969421339369 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5614.40392824 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0969923827152 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5672.56868969 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0970399348522 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5716.3213475 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0970868234819 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5741.54593461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0971293056828 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5751.47210553 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0971640702992 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5751.82439954 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0971899972804 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5748.12935776 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0972079256572 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5744.85395007 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.097220655535 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5745.09607197 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0972311904127 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5750.03847533 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0972427985994 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5759.13394445 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0972576179027 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5771.04764464 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0972764502774 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5783.98739025 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0972990980208 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5796.91863203 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0973241850661 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5808.71494114 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0973501554526 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5819.01113083 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0973756391303 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5827.91472808 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0973997309365 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5835.63405081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0974222909882 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5843.13665314 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.097443370362 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5850.69789865 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0974635035317 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5858.66856888 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0974834110756 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5817.19391802 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0975245537354 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5780.36687677 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0975779502758 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5793.99762298 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0976289339192 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5817.99361409 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0976753127121 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5844.79939568 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0977187562329 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.8991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5869.56761852 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0977607711232 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5889.25905782 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0978024730863 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5903.37292187 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0978442168196 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5912.41320903 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0978860436794 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5918.11215533 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0979277570699 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5922.44304772 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0979689378253 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5926.93596079 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980092009727 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5933.1048236 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980479846521 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5941.14491798 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980849215634 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5950.76827407 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981197639646 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5961.34912858 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981525252624 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5972.04676088 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981835700522 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5982.57992066 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982131522336 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5992.44199793 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982416650886 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6001.53626907 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982694940968 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6010.00214275 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982969671573 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6017.9026568 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.098324376324 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6025.86001007 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0983517085838 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6033.91942479 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0983788992031 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6042.20445879 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0984058337182 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6050.73441343 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0984323776329 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6059.27097257 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0984585465479 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6068.08638015 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0984842527809 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6076.9014442 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985095123091 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6085.64763354 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985343921669 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6094.30315259 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985590168729 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6102.672043 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985835561182 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6111.17037075 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0986080404577 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6119.66208338 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0986325380232 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6128.17581976 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0986570614621 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6136.72971117 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0986815966703 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6145.12771753 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0987061561344 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6153.72626323 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0987306506452 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6162.32530978 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0987550469717 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6170.90631257 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0987793210346 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6179.46394695 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0988034816698 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6187.79502443 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0988275885193 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6196.29361519 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.098851611856 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6147.97735585 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0987971073055 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6092.83438306 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.09860062573 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6087.75470683 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0983908907178 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6098.95702547 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982034370771 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6123.56053644 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980655762888 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6154.22724889 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0979866995936 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6184.21038251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0979612109428 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6208.7762652 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0979743335957 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6225.53767009 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980082261093 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6235.24941637 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980468133683 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6239.71137322 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980792257432 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6241.54768482 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981002496877 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6243.38082424 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981099575292 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6246.69296334 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981119425868 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6253.04840298 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981110355054 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6262.05670466 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981118161246 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6272.96118752 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.098117407643 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6266.17715395 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980962530397 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6272.04833645 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980664671589 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6282.37970871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980405193695 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6295.85490804 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980265948105 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6309.40157935 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980266180772 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6321.83996802 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.098038927964 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6332.73509244 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980600935333 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6341.83878414 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0980855689298 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6349.6160135 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981115545448 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6356.62088393 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981355041676 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6363.48853575 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981563608321 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6370.7784221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.098174546681 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6378.52198869 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0981907392536 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6386.86997055 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982061727028 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6395.70486694 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982220025693 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6404.80184801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982390151609 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6414.01882498 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982578078608 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6422.958155 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982780050457 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6431.62173785 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0982991897363 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6440.01577102 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0983208481031 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6448.20535495 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0983425169739 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6456.38054089 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0983641494787 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6464.44627333 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0983853312353 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6472.56276074 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0984060208484 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6480.77729285 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0984262970951 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6489.07579459 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0984462708356 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6497.54302699 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0984663655943 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6505.95253176 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0984864246635 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6514.34640951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985064704342 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6522.71533561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.098526506532 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6531.05235128 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985465167347 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6539.42789304 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985667345984 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6547.70425759 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0985868907683 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6555.9544886 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0986069330997 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6564.20047438 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0986268330414 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6572.44922001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0986465744834 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6580.75916685 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.098666402268 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6589.01169154 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0986860880638 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6597.25878271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.098705620226 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6605.51598315 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0987250089797 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6613.78558633 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0987442715012 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6622.10857101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0987636654423 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6617.80424965 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0987869269463 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6612.35992071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0988123505919 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6621.68740751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0988355631154 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 0.9991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6634.25334056 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0988575241169 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6646.82620747 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0988798280979 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6658.27198584 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0989031653556 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6668.31019726 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0989278479772 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6677.15120575 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0989537399062 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6685.2035877 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0989803953249 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6692.95319706 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0990074247476 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6700.67786904 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0990340144729 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6708.61499451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0990596264398 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6716.81964391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0990839147496 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6725.22400352 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0991066832047 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6733.73966574 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0991281544272 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6742.19403653 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0991483381515 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6750.53454156 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0991675439511 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6758.77662404 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0991861795728 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6766.95592485 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0992046438374 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6775.1074149 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0992234241679 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6783.2267965 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0992425094152 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6791.35294108 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0992619330012 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6799.50927572 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0992816234865 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6807.69533317 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0993014379674 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6815.90065852 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0993213905829 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6824.10346406 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0993411556548 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6832.29464899 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0993606130179 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6840.49722821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0993797232472 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6848.70629304 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0993984923669 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6856.90832593 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0994171395717 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6865.10526412 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0994355542678 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6873.28105707 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.099453779468 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6881.44560446 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0994718478721 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6889.59953999 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0994897763897 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6897.72305901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0995077370795 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6905.85312123 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0995255721154 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6913.97712103 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0995432782019 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6941.792218 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0995960501049 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6953.16166152 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0996551176545 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6954.60106015 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.099700286568 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6959.51965487 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0997355203343 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6965.8042696 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0997632473605 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6972.98102198 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0997857586709 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6980.78754812 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0998051976263 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6988.89959062 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0998234158027 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6997.18815185 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0998414467091 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7005.44567813 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0998599102504 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7013.60935562 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0998789694432 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7021.65284097 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0998984528851 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7029.55017298 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0999181782156 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7037.44093249 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0999376492872 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7045.31516797 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0999565681875 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7053.20428977 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0999747308793 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7061.16663934 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.0999921139028 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7069.11684313 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100008901534 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7077.16986211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100025103255 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7085.24689249 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100040890995 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7093.35825194 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100056446058 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7101.50302692 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100071927965 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7109.59868441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100087577996 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7117.77747803 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100103342832 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7125.95419455 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100119236342 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7134.12898542 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10013522729 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7142.2888783 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100151253671 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7150.33961743 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100167362582 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7158.43171841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100183374145 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7166.49236731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100199247565 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7174.55284824 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100214969871 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7182.63708352 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100230557592 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7190.65626801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100246147968 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7198.78999986 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100261668078 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7206.94473221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100277150564 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7215.12319427 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100292610704 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7223.31072509 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100308044737 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7231.3887569 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100323540051 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7239.53457438 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100338970121 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7163.0683939 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10039825043 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7095.71420714 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100488198756 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7102.62365518 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100573714836 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7116.54156754 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100655997425 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7141.16157196 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100731158276 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7172.24520045 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.100795726624 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6966.95615716 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101039131237 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6759.50599669 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10147169027 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6818.95894643 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10184397684 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6871.54301288 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102133098522 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6937.84224128 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102326721739 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7003.15686594 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102433688776 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7057.45064204 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10247357601 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7095.16201331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102469694451 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7119.16073273 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102440913314 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7131.03609913 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102402447074 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7135.53178135 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102364694324 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7136.95684692 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102333442134 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7138.0793906 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102311481504 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7142.15433038 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10229826973 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7149.03176288 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102292339456 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7044.95481336 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102276416965 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6902.58921627 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102151750076 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6889.5103693 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102000155 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6923.76654644 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101857879681 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6985.7153452 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101749652443 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7056.02118011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101685235485 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.0991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7119.41115401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101662179418 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7165.80118007 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101669733925 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7192.19552967 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101693455045 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7200.42004783 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101720285808 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7196.09872357 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10174125859 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7185.82327693 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101752276188 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7175.93366999 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101753972522 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7170.72782938 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101749859389 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7171.95470845 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101744442933 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7035.20869026 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.101884035256 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6919.14793633 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102167786495 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6934.85267765 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102442090362 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 6979.95581264 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102662955546 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7037.81846641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102815814094 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7094.597594 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102905507366 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7139.97448544 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102947423314 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7169.02451161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10296036291 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7181.70820756 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102961135365 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7181.88087475 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102962051521 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7175.27180191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102970290139 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7167.36410276 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.102988239843 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7162.58007382 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103015039985 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7162.66922286 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103047435502 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7168.59353409 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103082163145 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7179.01084424 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103116289313 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7191.96724422 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103147672369 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7205.51844494 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103175312209 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7217.8663954 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103199046892 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7228.17510158 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103219360543 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7236.21528339 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103237044605 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7242.33224651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10325294096 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7247.31192479 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103267791344 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7251.70939729 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103282076327 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7256.30204306 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103296097482 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7261.50828815 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103309992582 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7267.49149812 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103323842116 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7274.30913839 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103337710376 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7281.47873382 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103351586294 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7288.82508499 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103365441029 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7296.06381614 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103379216589 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7302.99869148 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103392843811 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7309.69532899 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103406238716 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7315.89007986 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103419362495 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7321.84506455 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103432200224 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7327.70998037 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103444774217 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7333.62358214 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103457154032 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7339.83067664 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103469430836 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7346.0647724 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103481734628 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7352.43410611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103494145341 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7358.87683738 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103506697341 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7365.30454947 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103519364206 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7371.7800155 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103532064488 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7378.02261427 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103544760827 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7384.15405965 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103557391165 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7390.2228291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103569926566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7396.28230613 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103582373471 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7402.47808816 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10359474628 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7408.63380112 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103607121949 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7414.84346004 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103619547652 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7372.27372254 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103642204591 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7339.22022886 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103659631328 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7349.92274382 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103671710025 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7369.64793742 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103683261053 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7393.24932172 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103696833569 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7416.05359293 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103713524343 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7434.84016169 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103733207512 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7448.20555333 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103754886326 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7456.29220421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10377731499 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7460.47710566 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103799166712 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7462.59360866 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103819429557 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7464.61698374 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103837723552 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7467.35921469 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103853411914 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7471.99195033 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103866839388 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7478.36264209 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103878429907 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7486.03805656 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103888804824 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7494.42725567 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103898647301 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7502.82729605 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103908425659 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7510.72488123 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103918565393 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7517.85418572 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103929256963 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7524.19481696 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103940503994 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7529.9125969 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103952174201 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7535.26204534 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103964014666 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7540.52578016 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103975864628 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7545.92130365 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103987549736 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7551.59261164 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.103998976351 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7557.56464071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104010114122 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7563.77915151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104020987423 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7570.17685682 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104031795615 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7576.59303723 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104042642056 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7582.93846917 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104053610094 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7589.13588695 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104064726548 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7595.17988955 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104075920596 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7601.06524722 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104087230372 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7606.85594252 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104098618122 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7612.62997137 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104110051831 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7618.44621247 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104121514209 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7624.3692082 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10413294489 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7630.33372183 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104144429298 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7636.3384951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104155973753 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7642.35921441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104167570575 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.1991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7648.36334016 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104179203944 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7654.36679075 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104190791468 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7660.28129024 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104202396125 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7666.14318655 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104214009567 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7671.98637819 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104225629611 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7677.83801022 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104237264584 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7683.75586199 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104248863831 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7689.66572825 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104260522527 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7695.58477017 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104272244261 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7701.51098188 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10428401664 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7707.43085482 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104295818757 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7713.36767424 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10430755998 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7719.24738987 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104319306833 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7725.09175167 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104331047072 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7730.92560456 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104342774354 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7757.27112303 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104383057342 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7765.95884755 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104429722773 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7764.76099133 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104465512859 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7766.86249199 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104492351796 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7770.42254295 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104512060163 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7775.2248769 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104526778742 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7780.88546469 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104538474717 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7786.87026391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104548836706 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7792.86801599 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104559023821 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7798.71013531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104569713565 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7768.66802558 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104555077255 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7683.9755693 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104460184753 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7719.12324263 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104382691127 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7788.14738497 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104358625058 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7853.98417753 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104390893181 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7903.16486154 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104465987107 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7932.21779436 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104564170972 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7943.31273174 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104666447094 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7942.26416061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104759270553 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7935.48051214 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104835557405 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7928.48073706 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104894391125 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7925.20488037 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10493931915 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7926.70319576 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.104975660391 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7933.03386338 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105008803041 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7942.71702694 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105042617283 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7953.7907468 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105078907105 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7964.71261147 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105117609534 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7973.71740623 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105157127696 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7980.50920146 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105195360475 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7985.20210962 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105230437514 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7988.46171509 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105261197578 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7991.28945081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105287379632 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7993.84900962 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105309248124 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 7996.91935422 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105327685368 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8000.78592449 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105343774817 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8005.45693708 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105358511249 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8011.04118615 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105372756464 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8016.6844269 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105386772206 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8022.36044367 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10540058891 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8027.84353447 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105413982656 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8033.0389807 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105426656251 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8038.20112928 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105438431723 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8042.82819404 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105448984304 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8047.25897061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105458198643 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8051.63713775 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10546610193 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8056.0854296 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10547287685 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8060.97031015 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105478909729 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8065.77224962 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10548434998 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8070.71692905 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10548939925 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8075.76256915 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105494186632 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8080.85983367 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10549877283 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8086.2160321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105503274149 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8091.23884645 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105507522644 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8096.14801112 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105511438297 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8100.94909699 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105514941193 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8105.72792095 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10551804893 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8110.76027766 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105520916191 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8115.57144248 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105523496525 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8120.42775713 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105525856488 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8125.33094811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105528048584 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8130.28898118 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10553011758 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8135.52367323 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10553220446 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8140.52528878 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105534205737 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8145.48609578 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105536091363 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8150.41393558 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105537834375 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8155.31618093 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105539416238 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8160.43474524 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105540962094 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8165.33613358 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105542398147 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8170.23279543 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105543743553 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8175.1508989 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105545020745 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8180.09421396 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105546240026 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8185.26654294 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105547525687 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8190.24244188 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105548786968 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8195.19277824 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105550003836 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8200.13031834 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105551157124 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8205.06052981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105552234523 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8210.17994208 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105553330778 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8215.11936315 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105554378326 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8220.04745916 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105555384974 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8224.98511571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105556359169 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8229.93626081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105557306179 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8235.06900359 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105558318277 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8240.03888606 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105559323099 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8244.98588959 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105560306777 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8249.92553703 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10556125574 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.2991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8254.86358055 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105562160039 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8259.95673752 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105563102184 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8243.08129891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105572214566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8229.52846252 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105586046371 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8237.30866989 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105597111884 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8248.767057 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105606180831 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8258.80645691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105614919398 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8266.83269818 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105624501782 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8273.03915785 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105635296582 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8277.96640619 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105647055576 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8282.34714439 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10565919786 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8286.83220284 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105671048495 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8291.57852069 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105681879233 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8296.77575952 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105691187154 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8302.30558722 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105698695204 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8307.93855252 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105704362637 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8313.54607994 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105708429096 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8318.86814311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105711251151 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8323.91682724 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105713267368 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8328.75902776 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105714916315 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8333.49528249 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105716580634 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8338.31080495 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105718580844 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8343.12238272 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105720986182 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8348.01551746 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105723754705 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8352.99315987 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105726727851 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8358.01348038 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105729683503 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8363.11265464 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10573246379 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8403.04200557 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105771840191 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8481.98669604 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105842175037 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8470.43830388 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105903473814 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8428.83488461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105930163933 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8384.22401619 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105918000721 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8349.66872682 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105874246038 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8330.65493845 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105811975723 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8327.22423959 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105744890285 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8335.56140224 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105683690073 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8350.91169988 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105634974666 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8368.09850647 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105600358975 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8262.81683322 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105653769826 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8173.96300993 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105779611506 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8185.71018418 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.105902029664 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8208.84819049 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10600169315 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8242.30327896 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106067097227 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8278.49036616 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106097149559 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8310.79890638 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106098441026 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8335.22783903 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106081884277 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8350.3613411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106058844748 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8357.22492979 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106038412732 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8358.3899125 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106026132687 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8357.08781948 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106023803376 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8355.99995719 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106029898407 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8356.95932743 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1060410543 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8360.68927654 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106053157106 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8367.34013385 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106063303346 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8376.04136838 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10606952915 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8385.68470136 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106071291677 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8395.2063111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106069169978 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8403.86404203 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106064505597 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8411.2753258 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106058782944 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8417.44845542 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10605329807 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8422.65718245 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106048931463 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8427.31353465 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106046021097 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8427.78157225 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106039964724 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8430.70358107 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106031079739 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8434.59184829 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106021899369 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8440.74806986 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106014786531 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8447.81813075 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106010587004 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8455.41394207 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106009694285 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8462.81394603 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106011648556 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8469.62874197 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106015537184 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8475.67970342 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106020298578 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8480.97853019 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106024942292 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8485.77933308 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106028917618 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8490.36016868 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106032005571 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8495.00551929 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106034324199 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8499.917878 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106036226645 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8505.16486907 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106038104025 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8510.75682487 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106040444288 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8516.56602199 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106043552648 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8522.46295949 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106047575663 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8528.30716415 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10605249062 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8533.98236406 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106058059156 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8539.49652646 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106064114705 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8544.84309181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1060704135 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8550.08065511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106076771775 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8555.29318913 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106083099131 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8560.51868193 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106089311537 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8565.84139961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106095518849 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8571.2363069 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106101793815 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8576.6859641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106108205962 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8582.15748145 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106114805324 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8587.5908162 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106121540563 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8593.03021579 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106128490115 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8598.41046978 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106135612629 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8603.75458154 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106142875388 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8609.07939454 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106150245935 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8614.37228019 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106157622719 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8619.7091535 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106165064311 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8625.0556387 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106172563872 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8630.41187809 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106180116603 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.3991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8635.77039993 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10618772038 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8641.08924317 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106195295232 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8646.43419705 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106202919273 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8651.76167405 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106210594197 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8657.07982643 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106218319327 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8662.3960579 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106226094223 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8667.68012192 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106233836464 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8673.01320127 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10624162535 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8678.34707991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106249457726 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8683.68208853 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106257325964 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8689.01378914 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106265221844 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8694.29823647 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106273054205 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8699.61840766 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106280903191 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8704.92369364 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106288768311 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8710.22266765 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106296650027 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8715.52155766 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106304551301 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8739.59072073 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106334637654 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8750.92893369 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1063732386 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8750.82254179 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106404436526 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8752.26974468 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106428019419 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8753.97494171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106443960824 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8756.17861434 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106453260501 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8759.3997461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106458118163 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8763.49032972 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106460753348 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8768.31363466 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106463089746 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8773.76168478 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106466540895 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8779.45445962 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106471680813 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8785.34872567 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106478761434 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8791.1517209 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106487404815 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8796.74603778 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106496936997 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8802.0918954 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106506626233 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8807.10957649 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10651572391 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8812.10151882 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106524022854 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8817.00843529 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106531391936 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8821.91800721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106537934977 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8761.6674788 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106576211919 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8663.57511713 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106654486112 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8711.31386827 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106710216858 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8769.86134042 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106738480225 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8820.26452359 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106741847475 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8855.16925635 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106727202437 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8874.9217034 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106702285905 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8883.29628201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106674365226 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8885.15381408 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106648879152 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8885.06657512 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106629343271 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8886.39389087 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106617433783 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8890.88326633 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106613074587 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8898.65605273 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106615301237 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8908.84578609 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106622246829 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8920.11741607 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106631798737 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8931.17705358 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106642100379 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8941.07715957 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106651597166 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8949.28164149 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106659700149 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8955.78771318 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106666244014 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8960.96687959 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106671524664 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8965.35678029 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1066761191 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8969.54369631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106680516722 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8973.85773687 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106685468106 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8978.5420166 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106691368912 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8983.65776421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106698370161 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8989.11809861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106706390863 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8994.81772241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106715073959 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9000.48297262 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106724310786 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9005.99055223 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106733841544 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9011.26682181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106743447564 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9016.29410719 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106752985174 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9021.16283608 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106762249512 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9025.84193886 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106771393539 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9030.43464773 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106780476023 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9035.02400041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10678956942 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9039.66414767 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106798745381 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9044.43059074 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106807931959 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9049.22949702 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106817291752 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9054.0576749 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106826827319 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9058.88774363 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106836503057 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9063.6843448 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106846259177 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9023.12574591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10688614728 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9009.54611531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.106962954676 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8993.14479498 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107046521183 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8980.2580404 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10712280116 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8974.92179089 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107185171003 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8978.23000115 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107231508655 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8987.65227325 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107263443249 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8999.34690963 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107284060882 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9009.98551623 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107296905032 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9017.52424368 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107305091857 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9021.38900866 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107310871412 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9022.1675925 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107315768003 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9021.23758104 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107320577258 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9019.89001503 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107325264232 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9019.31050634 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107329544557 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9020.27420547 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10733306183 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9023.22310609 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107335828903 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9027.87092071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10733791914 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9033.71176902 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10733950608 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9040.11022106 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107340781653 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9046.45621153 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107341836008 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9052.39295066 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107342808895 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9057.64583785 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10734372275 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9062.22481384 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107344529389 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.4991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9066.32308054 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107345184712 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9032.74122942 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107361542324 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8993.08632097 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107393570042 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8996.70883536 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10742374024 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9011.54289208 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107449751884 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9031.29164838 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10747055412 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9051.31560248 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107486311693 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9068.3568678 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107498111377 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9080.70906602 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107507337867 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9088.28664034 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107515450498 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9092.01504804 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10752341072 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9046.62541762 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107514606724 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8919.22433465 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107470055222 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8943.26885092 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107438267434 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9007.58463857 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107427808117 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9073.61496278 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107437068019 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9126.48180353 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107459907209 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9161.15070488 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107489236102 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9178.7555932 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107519285709 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9183.73844135 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107546894479 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9181.62297381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107570969377 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9178.38025061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107592953349 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9176.25593224 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107614206339 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9106.88885712 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107645722657 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9082.04998351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107680867143 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9056.76857512 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107702121207 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9038.17029159 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107705544036 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9033.18925606 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107693703328 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9041.46135707 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107671896407 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9058.60624145 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107645824236 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9079.02954988 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107619902932 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9097.70433082 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107596528208 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9111.02876687 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10757641301 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9117.97733043 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107558889069 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9119.19334966 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107542680294 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9116.86144945 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107526699569 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9113.23446034 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107510039137 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9110.4980999 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107492757643 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9110.07908937 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10747528618 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9112.7912802 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107458601187 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9118.38212495 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107443556084 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9126.08917751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107430690255 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9134.52653697 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107420287933 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9142.68128778 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107412150384 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9149.76226388 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107405768242 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9155.40951272 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107400510469 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9159.7820354 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107395733888 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9163.1132571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10739118329 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9166.06039259 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107386810366 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9169.17177178 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107382786202 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9172.82669599 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107379407435 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9177.29606526 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107376947008 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9182.27074299 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107375652124 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9187.60402635 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107375567627 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9193.00444573 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107376557323 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9198.21804165 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107378372201 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9192.07409104 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107370880394 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9147.97473999 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107322484799 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9168.63388267 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107290299637 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9198.05306698 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107284200316 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9223.2063818 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107299756404 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9241.80855968 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107329156222 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9253.73081496 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107364669017 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9260.40485585 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107400283198 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9263.69367719 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107432276497 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9265.57628987 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107459192774 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9267.68995603 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107481352036 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9290.25174006 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10751229379 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9335.76349565 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107567970808 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9317.03238398 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107606233694 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9293.08751233 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107620488277 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9273.47387645 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107614688618 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9261.53413296 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10759607011 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9257.72875335 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107572171068 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9260.23907214 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107548634849 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9267.01618381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107529167933 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9275.54703891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107515068725 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9283.81344694 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107505950577 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9290.47942105 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107500215099 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9295.06353039 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107495867698 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9297.82115149 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107491282463 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9299.40832291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107485347243 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9300.79964553 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107477995145 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9302.69058342 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107469726294 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9305.55464578 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10746141223 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9309.51479065 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10745395908 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9314.38254001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107447970392 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9319.90142351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10744394757 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9325.59533587 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107441920885 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9331.11488043 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107441612596 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9339.77888975 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107445830515 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9347.16565457 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10745311207 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9347.37042295 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107457186175 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9349.88741878 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107459701151 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9352.52218406 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107460868771 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9355.48053202 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107461082081 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9358.83811847 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107460777538 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9362.74216174 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107460576102 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9367.02711488 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107460885239 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9371.64163285 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107462021497 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.5991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9376.37012043 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107464049435 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9381.00056312 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107466800022 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9385.56342396 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107470150895 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9389.92968043 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107473855035 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9394.13920742 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107477720759 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9398.24173341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107481613036 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9402.22962467 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107485396167 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9406.30257586 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107489137295 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9410.44542213 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107492903938 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9414.68037991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107496779313 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9419.00417201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107500841166 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9423.32279808 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107505076955 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9427.73721071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10750956159 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9432.14589032 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10751428566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9436.5188528 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107519202061 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9440.83712788 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107524244894 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9445.02606205 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107529288124 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9449.23492871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107534329986 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9453.41871507 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107539349767 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9457.60350011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107544344548 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9461.80985497 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107549329206 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9465.97493455 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10755427388 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9470.24234471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107559251281 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9474.53230611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107564286797 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9478.83175929 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107569386133 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9483.12456305 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107574539316 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9487.32123673 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1075796759 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9491.56633223 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107584816371 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9495.78671378 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107589948515 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9499.99391285 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107595062762 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9504.19963506 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107600157393 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9508.33026069 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107605189836 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9512.5545444 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107610211414 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9516.79083469 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107615238825 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9521.03830089 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107620279585 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9525.28993722 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10762533344 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9529.44841308 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107630348218 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9533.68390251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107635354885 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9537.90511367 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10764035134 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9542.11800119 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107645333423 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9564.84475753 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107667153062 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9575.10195282 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10769593504 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9574.39807283 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107719507662 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9574.59084189 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107737294609 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9574.92828194 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107749117988 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9575.85302484 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107755782784 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9577.74120337 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10775876845 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9580.80073618 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107759900156 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9584.70772526 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1077607101 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9589.1514167 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107762208436 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9593.97250983 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107765011259 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9598.73663328 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107769220777 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9603.45537528 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107774620344 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9607.92357356 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107780710615 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9547.6765302 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107814826738 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9493.66630228 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107873112154 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9496.8198249 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107929418545 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9510.5250309 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.107979037462 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9532.99019321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108018150802 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9558.27529935 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108045671328 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9581.42699365 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108062885635 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9599.17191877 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108072739309 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9610.47723597 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108078808701 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9615.76939749 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108084266542 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9616.73312591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108091176803 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9615.70118964 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10810061862 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9614.43482944 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108112185182 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9614.65135833 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108124831751 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9616.65356082 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108136939805 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9620.92261247 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108147568113 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9626.94443469 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108156135574 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9633.88227782 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108162543072 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9641.0545419 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108167240199 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9647.73502308 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108170926076 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9653.51969014 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108174291517 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9658.2949284 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108177845596 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9662.14122905 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108181831352 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9665.46138081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108186338375 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9668.55591301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10819123926 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9671.76772621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108196334898 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9675.35973348 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108201463354 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9659.97502376 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108213796101 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9643.96750421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108232725244 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9646.72727353 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108250692048 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9658.41758921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108266066593 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9670.57593083 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108279365859 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9681.24034364 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108291330089 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9689.71074434 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108302621714 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9695.77992035 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108313631785 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9699.86519246 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108324477995 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9702.74339875 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108335037972 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9705.25329769 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108345148279 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9708.01976302 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108354689528 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9711.40223995 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108363534957 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9715.4861921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108371564455 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9720.10942066 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108378700991 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9725.02405766 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108385047227 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9730.00328807 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108390773479 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9734.8214992 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108396091447 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9739.38505659 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10840122809 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.6991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9743.69461167 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108406430386 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9747.79190061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108411845205 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9751.78481315 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108417543743 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9755.72311807 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108423497299 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9759.66520839 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10842959478 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9763.6415803 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108435679893 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9767.68629188 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108441586452 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9771.75632106 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108447226808 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9775.85345012 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108452564467 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9779.92891663 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108457577289 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9784.08438195 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108462422196 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9788.21703594 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108467117691 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9792.33626138 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108471799998 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9796.47786076 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108476591194 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9800.57599007 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108481499992 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9804.62658008 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108486504478 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9808.66155173 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10849154013 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9812.64323834 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108496585758 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9816.61208533 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108501609773 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9820.59275637 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108506597735 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9824.60020505 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108511558931 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9828.6638157 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108516491938 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9832.72936858 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108521435855 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9836.80155652 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108526405024 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9840.86977626 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108531401837 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9844.92210342 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108536419116 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9848.97288385 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10854142687 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9852.98335965 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108546431074 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9856.97647554 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108551426249 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9860.968701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108556412315 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9864.97080283 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108561395273 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9869.00423664 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108566368166 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9873.03534284 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108571354256 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9877.06907416 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108576357828 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9881.10246295 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108581376206 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9885.12932841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108586402414 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9889.15765688 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108591414238 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9893.1643656 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108596418472 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9897.16003212 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108601412763 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9901.15593907 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108606397895 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9905.15867257 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108611378252 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9909.17665699 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108616347017 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9913.19786159 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108621321866 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9917.218943 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108626305489 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9921.23965791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108631295551 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9925.25634906 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108636286947 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9929.26698652 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108641262886 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9933.27053962 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108646229591 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9937.26540845 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108651185592 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9941.26052326 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108656131106 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9945.26060129 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108661068812 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9878.99865179 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108704408776 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9809.21801046 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108789998274 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9809.99421112 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.108874744865 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9823.60948292 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10894788712 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9848.89589225 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109000930064 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9878.77520909 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109031388921 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9906.80655759 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109042164548 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9928.5130351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10903941848 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9941.84867971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109030266954 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9947.1257748 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109020880082 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9946.35845256 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109015252161 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9942.6943032 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109015477527 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9938.75535335 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109021215157 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9936.78280866 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109030761154 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9937.52605461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109041579609 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9941.60206775 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109051750165 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9948.12333178 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109059761159 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9956.03419447 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109064945159 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9964.1781932 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109067399322 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9971.59827951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109067772333 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9977.75102007 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109066896977 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9982.38947803 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109065597566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9985.74623511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109064528753 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9988.2685165 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109064073222 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9990.48852742 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109064359334 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9992.94755295 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109065299067 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9995.8741512 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109066763317 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9999.48662309 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109068631558 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10003.679019 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109070748568 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10008.3813445 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109073097936 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10013.2976551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109075585911 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10018.0710447 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109078173228 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10017.6694512 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109076730072 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9996.10464385 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109054330505 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10013.2508327 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109042596313 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10034.1592755 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10904691747 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10050.9263379 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10906411812 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10062.436361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1090888563 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10069.4584326 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109116091994 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10073.3787401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109142035392 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10075.7813159 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109164623905 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10077.7121744 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109183029864 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10080.1077013 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109197710031 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10083.3827718 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109209851991 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10087.5205811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109220760864 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10092.4833084 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109231598499 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10097.5849344 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109243082741 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10102.5616806 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109255411729 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10107.1447434 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109268315785 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.7991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10111.1986781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109281232023 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10114.8770506 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109293591837 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10118.0254167 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109304850759 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10120.9469194 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109314685501 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10123.8313859 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109323005003 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10126.7902528 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109329903574 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10130.0410069 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109335692007 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10133.3472586 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109340642447 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10136.8094191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10934507379 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10140.4096077 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109349265447 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10144.0920495 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109353406189 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10147.9215065 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109357635317 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10151.5940627 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109361900204 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10155.1870194 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109366122136 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10158.6792118 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109370186179 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10162.0692461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109373975191 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10165.4985065 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109377451485 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10168.7677812 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109380534523 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10172.0413397 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109383252984 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10175.3660493 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109385681089 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10178.7700229 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109387921633 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10182.3694589 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109390122734 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10185.931517 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109392321467 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10189.5278447 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109394562241 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10193.1205601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109396848129 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10196.6743698 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109399148851 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10200.2694405 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109401460161 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10203.7067183 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109403696623 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10207.1001367 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109405830765 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10210.4812198 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109407859983 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10213.8814753 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109409804432 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10217.4124983 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109411735823 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10220.9036147 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109413654363 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10224.4307156 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109415587681 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10227.979059 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109417548566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10231.5264008 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109419532421 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10235.1322616 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109421554836 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10238.6309969 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109423563044 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10242.09876 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109425542018 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10245.5518286 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109427487773 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10249.0065824 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109429406794 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10252.5446779 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109431341077 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10256.0373982 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109433278006 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10259.5468799 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109435229943 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10263.069803 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109437202033 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10297.9495256 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109465849391 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10322.9703421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109510796569 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10318.6149423 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109548053004 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10307.10864 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109569997368 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10292.9811127 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109573955777 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10281.4199022 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109562581262 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10274.3502353 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109540981783 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10272.3637786 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109515149048 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10274.6994126 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109490248684 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10280.1241094 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109469888143 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10287.0206287 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109455742045 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10294.0530163 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109447642209 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10300.1302284 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109444086039 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10304.8801506 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109443020835 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10308.3085855 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109442443858 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10310.7866941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109440922424 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10312.8221254 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109437726253 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10314.8066188 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109432847684 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10317.1818338 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10942689021 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10320.1977132 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109420771856 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10323.8934252 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109415393451 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10328.2866629 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109411547459 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10333.0821882 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109409685581 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10338.0509622 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109409871431 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10342.936378 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109411821544 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10347.5104978 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109414996244 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10351.7210751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109418818951 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10355.4796468 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109422718931 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10333.1308236 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109432874409 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10296.0115801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10945475058 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10317.5787273 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109471355605 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10322.6587827 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109467402657 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10279.6842375 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109427289373 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10328.8669996 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109398117313 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10370.8308979 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109369803955 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10407.1422541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10935733853 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10419.4478812 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109356465251 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10419.0285355 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109362769433 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10412.8985887 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109372195469 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10405.7813145 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109381436662 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10401.0198658 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109388374477 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10400.4234267 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109392326467 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10418.2774792 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109404991122 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10394.826863 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109433255399 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10374.5413458 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109465414989 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10373.5759255 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109492349262 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10369.8490065 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109512209246 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10369.101994 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10952526587 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10371.2628397 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109531944367 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10376.2201542 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109534162429 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10382.4279405 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109533761421 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10388.5633119 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109532268296 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10393.8728446 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109530953077 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10397.9793049 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109530606983 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10400.9218155 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109531504387 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.8991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10403.0843444 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109533524008 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10404.8768273 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109536205615 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10406.9211369 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109539183775 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10409.4526351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109542074073 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10412.5957939 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109544582037 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10416.3188587 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109546560302 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10420.4471792 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109547977084 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10424.8469656 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109548997343 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10429.2370984 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109549792547 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10433.5143004 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109550573928 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10437.631861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109551547575 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10441.4791808 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109552782429 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10445.1292955 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109554316533 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10448.5930199 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109556104285 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10451.9587859 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10955805824 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10455.319315 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109560092497 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10458.7051465 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109562120177 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10462.2354886 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109564126942 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10465.8693286 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109566118874 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10469.6021141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109568127087 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10473.3982175 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109570192211 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10477.1595419 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109572334015 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10480.9376338 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109574586646 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10484.6285914 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109576949423 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10488.2295375 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109579406584 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10491.7550009 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109581936851 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10495.1739741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109584510869 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10498.65233 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109587139425 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10502.1429682 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109589829263 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10505.6776881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109592591563 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10509.2641815 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109595436036 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10512.8221773 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109598354996 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10453.3579374 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10959007571 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10402.9513223 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109567792647 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10405.1877458 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109544699566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10403.4693227 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109534993751 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10400.2622313 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109539540039 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10429.3007029 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109547708773 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10458.4366361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109558479607 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10484.4024521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109570007217 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10503.5016193 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109580782004 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10514.8618267 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109589909241 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10518.870406 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109597020354 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10517.9739979 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109602320507 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10514.9779561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109606510249 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10512.2551777 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109610194963 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10511.967134 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109614102814 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10513.9441088 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109618303277 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10518.6167956 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10962294979 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10525.1545715 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109627901895 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10532.5046939 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109632927917 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10539.9759546 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109637941143 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10546.175127 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109642633793 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10551.0068604 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109646924262 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10554.4976956 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109650858704 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10556.9648659 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.10965456448 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10559.2460373 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109658311591 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10561.1632573 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109662094665 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10563.4382907 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109666042489 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10566.2910441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109670226487 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10569.7586447 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109674631587 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10574.099138 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109679309946 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10578.3598332 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109684026406 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10582.5924423 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109688668349 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10586.610089 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109693151615 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10590.2831724 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109697402814 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10593.9660761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109701490071 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10597.0233801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109705319409 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10599.9024017 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109708943266 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10602.7709469 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109712455199 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10605.7557933 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109715956715 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10553.3173066 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109743634565 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10498.0791777 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109797302382 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10496.4802105 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109852920054 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10509.0841736 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109901579091 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10477.1636495 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.109961208608 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10459.322184 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110028368628 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10483.3069994 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110081283477 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10516.2497546 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110114237079 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10547.383025 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110127826237 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10571.568789 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110126508749 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10587.1564063 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110116642613 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10593.6886515 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110104226136 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10593.6941779 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110094059875 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10590.4972672 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110089068292 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10586.7577034 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110089710304 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10585.3861836 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110094925829 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10586.1703282 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110102284674 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10590.2354489 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110109682854 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10596.8011042 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110115345552 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10604.7566422 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110118323353 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10613.3662092 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110118598208 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10620.6915989 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110116661134 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10626.5601474 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110113429424 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10630.8056276 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110109836731 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10633.641389 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110106687315 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10636.0529665 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110104583559 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10637.6607919 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110103649133 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10639.4448022 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110103781014 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10641.7667824 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110104742767 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 1.9991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10644.769556 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110106270822 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10648.8655221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110108152 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10653.0062563 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11011019544 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10657.3155004 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110112279653 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10661.4849148 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110114323243 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10665.411072 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110116359182 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10669.4424832 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110118468536 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10672.6259503 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110120627511 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10675.5267221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110122878621 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10678.2847898 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110125249064 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10681.0439482 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1101277416 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10684.4110657 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110130435095 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10687.4946797 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110133302507 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10690.7274002 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11013633222 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10694.0713378 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110139512277 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10697.4466057 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110142810341 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10701.2733781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110146241526 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10704.5470554 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110149715446 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10707.7023288 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110153192994 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10710.7564959 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110156654878 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10713.7488917 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110160098667 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10717.2031673 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110163589041 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10720.2279108 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110167112568 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10723.2892475 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11017068789 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10726.3862821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11017432582 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10729.5020932 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110178020862 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10733.0875414 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110181800212 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10736.204996 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110185601622 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10739.2840673 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110189400374 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10742.3260697 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11019318148 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10745.341593 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110196941191 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10748.8133324 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110200728665 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10751.85115 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11020451626 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10754.8958195 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11020831141 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10757.9465922 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110212120324 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10760.9957384 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110215941427 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10764.4933484 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110219810332 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10767.5423513 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110223679785 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10770.5672047 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110227537093 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10773.5717582 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110231375971 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10776.5633043 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110235193684 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10780.0026183 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110239033784 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10783.0229648 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110242865401 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10786.0463439 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110246691154 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10789.0712542 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11025051425 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10792.0921936 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110254333899 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10795.5460456 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110258187881 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10798.5710353 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110262035345 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10801.5774156 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110265868003 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10804.5683954 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11026968206 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10807.5490206 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110273475767 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10810.9574657 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110277288521 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10813.9638622 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110281090988 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10816.9708916 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110284884566 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10819.9782712 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110288671551 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10822.9821807 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110292451327 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10826.4001268 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110296258374 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10829.4145291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110300058062 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10832.4146715 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110303844492 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10835.4025567 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110307614939 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10838.3808655 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110311367319 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10841.7661431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110315137594 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10844.7655731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110318896722 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10847.7625576 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110322645071 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10850.7578758 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110326384402 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10853.7493976 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110330113999 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10857.139302 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110333867755 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10860.1451766 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110337613329 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10863.1400861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110341346368 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10866.1254267 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110345065188 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10869.1023913 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110348767742 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10872.4697066 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110352489038 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10875.4651405 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110356198934 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10878.4562049 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110359896801 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10881.4440849 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110363584043 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10884.4275733 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110367259943 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10887.7941418 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110370958652 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10890.7935029 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110374648381 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10893.784073 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110378325684 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10896.7670053 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110381989689 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10899.7426649 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11038563863 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10903.0929262 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110389307503 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10906.0857637 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110392965123 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10909.0733319 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110396610126 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10912.0568357 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110400243533 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10915.0354603 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110403864605 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10918.3812755 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110407508039 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10921.3760072 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110411141917 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10924.3633145 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110414763318 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10927.3340665 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110418361556 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10930.3019085 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110421942431 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10933.6438307 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110425552686 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10936.6425964 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110429160475 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10939.6241041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110432750317 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10942.6023647 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11043632618 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10945.5792156 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110439888333 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10948.914899 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110443482494 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10951.9125617 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11044707209 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10954.8900948 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110450640232 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10957.8619987 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110454191018 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.0991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10960.8315429 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110457722399 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10964.1544834 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110461281571 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10967.1386975 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110464826391 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10970.1196683 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110468357901 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10973.1089962 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110471885567 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10976.0801916 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110475398567 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10979.3962772 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110478943597 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10982.380618 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110482472679 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10985.36003 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110485984358 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10988.3364567 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110489477147 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10991.3059222 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110492954901 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10994.612306 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110496465519 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10997.5965514 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110499961712 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11000.5773946 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110503443153 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11003.5570059 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110506909763 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11006.5297466 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110510364625 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11009.8297919 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11051385487 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11009.3239566 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110514793467 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10992.077948 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110502386141 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11002.9268177 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110494836877 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11019.7877923 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1104980061 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11033.4354655 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110509615455 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11042.3121376 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110525944963 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11048.4737546 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110544369697 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11052.4855339 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110562673654 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11055.2331676 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110579568409 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11057.7516692 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110594463343 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11083.5388253 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110621994617 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11112.7661659 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110665885505 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11108.1375709 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110703957577 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11094.1274185 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11072757236 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11077.8108498 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110734804883 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11063.4450544 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11072776096 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11053.8635052 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110711042275 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11049.9761386 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110689945144 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11051.3048044 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110669239286 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11057.0950751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110652669229 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11064.8555837 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110642014705 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11072.9434524 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110637218466 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11079.904076 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110636876683 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11084.9090661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110638867338 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11088.1503591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110641099376 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11089.4052095 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110641962417 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11089.649061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110640574522 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11089.8746924 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110637045667 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11090.7060278 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110632057054 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11093.0284282 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110626768924 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11096.0828605 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110622169739 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11100.1057856 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110619080809 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11104.6776673 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110617940252 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11109.3413287 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11061872416 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11114.0424209 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110621068036 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11117.876543 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110624350734 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11106.2182508 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110633190005 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11095.3035505 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110645827982 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11097.8020216 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110657145944 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11103.7286329 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110666617246 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11110.3493264 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110674327543 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11117.0192945 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110680752822 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11123.1244537 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11068643055 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11128.3684939 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110691834296 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11132.8931059 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11069726483 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11149.0647044 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11071090955 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11158.0254756 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110729425442 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11157.6495717 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110745407588 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11157.545465 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110758209905 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11157.55929 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11076734502 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11157.7090142 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110772908441 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11158.1796591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110775310399 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11107.9030213 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110795320323 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11071.696687 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110827964712 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11077.0466513 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11085851474 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11091.0578335 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110884896995 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11108.6508733 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110906337911 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11126.3079504 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11092280729 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11141.4157058 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110934920914 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11152.6856741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.110943686592 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11092.9086495 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11112808728 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11440.3629796 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11214976465 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11798.5516333 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.114022502735 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11842.6432464 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.116271912576 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11466.9042411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.118246470337 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10822.7656996 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.119460340682 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10183.9687489 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.119761843125 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9844.22717048 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.119363955421 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 9970.86266095 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.118711807819 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10537.1998575 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.11827748359 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11355.6498167 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.118385057301 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 12142.3072131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.119108430017 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 12632.1467625 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.120269264724 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 12657.4530764 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12151992642 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 12224.4001113 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.122498841284 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11501.2401742 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.122970255857 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10745.8740549 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.122897911326 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10207.2319487 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.122437088893 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10031.7028018 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.121849827306 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10251.8138847 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.121416041737 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10762.4022229 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.121328068951 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11377.1008898 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.121633928018 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11890.5672122 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.122232255595 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.1991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 12154.8035693 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.122925778605 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 12104.4296393 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123492385688 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11793.6159166 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123773871903 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11356.2694561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123725782921 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10946.3094665 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123417747905 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10692.4640341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12300222618 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10663.7328782 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12265605927 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10841.3714314 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.122514984814 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11138.0786079 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.122628798918 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11442.8339819 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.122955014992 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11655.3599556 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123379844483 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11710.5072407 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123759493448 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11611.3009449 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123977679421 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11412.8759966 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123983195785 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11199.5197204 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123801458794 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11045.8917155 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123517248662 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 10972.9969225 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123246640749 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11018.5851442 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123091668809 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11167.7174562 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123106217928 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11336.715708 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123279362297 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11465.5279774 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123548439465 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11508.7717385 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123818072425 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11458.1186803 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123998880164 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11343.1848502 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124038649729 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11215.361854 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123937175578 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11123.3269414 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123740511235 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11104.6716767 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123526594861 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11163.8094226 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123373725467 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11277.8405721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123333993514 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11402.8235079 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12341690826 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11477.6940887 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123581473606 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11487.5484957 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123765322493 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11442.6231301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1239115509 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11346.6204406 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123971024539 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11237.7450486 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123928952957 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11153.6743997 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123804478459 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11129.0097694 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123646165168 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11170.057705 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123511396292 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11264.1150694 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12344633757 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11378.177633 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12347062475 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11474.1396048 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123572684895 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11522.3995496 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12371532607 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11508.5554737 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123850847579 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11440.7794252 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123935617169 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11344.7717183 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123945975335 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11255.6570603 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123885604143 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11203.1500857 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123780182123 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11203.7421212 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123670244847 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11256.6844428 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123595209896 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11342.7115522 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123580059398 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11432.0859141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12362759681 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11498.2499108 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123720631658 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11518.022098 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123826105314 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11489.9159526 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123909340412 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11426.4517999 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123945213387 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11352.2628833 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123926717734 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11293.0749382 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12386467001 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11268.129344 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123784196277 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11285.2101807 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123715019442 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11337.1053288 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12368115887 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11405.1940782 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123692904364 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11467.5306455 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12374421768 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11504.2740406 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123817065478 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11505.4291367 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123886336126 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11474.0119062 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123929903436 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11423.6527466 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123936229329 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11373.9482644 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123906858462 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11339.978858 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123854709297 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11334.8887278 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123800152657 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11358.9700651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123762871807 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11403.1575505 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12375528475 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11453.2604722 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123778996508 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11491.1972799 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12382441375 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11507.8293469 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123875986307 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11499.1492811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12391666328 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11470.6566405 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12393413189 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11435.3948423 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123925125298 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11404.6272723 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12389523611 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11389.894209 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123856480326 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11396.2119949 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123823548495 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11421.0984733 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12380818926 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11456.5686687 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123815364261 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11489.2329219 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123841685962 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11510.6723262 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123878026134 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11514.7958794 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123912013537 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11502.3462925 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123932845274 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11480.5648212 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123935171654 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11456.7771458 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123920048047 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11440.6352866 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12389426001 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11438.1833766 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123868062395 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11450.3781397 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123851186743 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11473.18357 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123849443637 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11498.6342698 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123863288987 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11519.0943093 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123887594446 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11529.2500412 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123914313628 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11526.9606414 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123934851163 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11515.0984278 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123943085345 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11498.8306224 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123937862515 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11484.8496365 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123922264217 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11478.9593245 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123902953327 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.2991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11483.4284372 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123887424922 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3001 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11497.2759331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123881329272 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3011 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11515.5800426 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123886957631 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3021 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11533.0318594 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12390233758 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3031 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11544.892361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123922451889 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3041 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11548.1732365 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123940866751 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3051 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11543.563036 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123951953506 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3061 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11533.5616306 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.1239531804 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3071 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11523.2244559 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123945481353 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3081 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11516.7462946 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12393259061 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3091 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11517.1470645 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123919918849 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3101 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11525.1153058 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123912393853 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3111 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11537.7891063 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123913102759 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3121 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11551.795897 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123921997575 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3131 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11563.1491407 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123936250476 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3141 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11569.309833 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123951558659 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3151 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11569.5396675 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123963249497 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3161 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11564.444549 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123968416129 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3171 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11557.4158337 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12396646407 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3181 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11551.6741572 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123959166913 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3191 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11550.2213845 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123950161239 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3201 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11554.4565421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123943238598 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3211 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11562.832869 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123941557384 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3221 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11573.4958898 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123946220191 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3231 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11583.5545603 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123956076805 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3241 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11590.6402993 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123968414091 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3251 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11593.7298723 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123979629551 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3261 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11588.8916109 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12398810136 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11572.7810505 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12399536177 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3281 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11518.8220431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12399147221 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3291 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11476.9201421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123977497016 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3301 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11472.3223683 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123966853818 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3311 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11478.2672931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123963627619 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3321 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11491.4624125 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12397033509 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3331 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11506.9618213 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.123987056401 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11520.1536826 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124011653568 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3351 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11528.3243416 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124040615273 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3361 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11529.8553845 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124070789279 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3371 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11524.9464378 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124098849385 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3381 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11516.3794153 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12412339208 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3391 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11506.9554186 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124144722072 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3401 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11499.870995 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124164414983 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3411 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11495.4185999 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12418461289 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3421 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11494.2841341 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124207029794 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3431 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11495.8450801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124232571547 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3441 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11498.374551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124260869158 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3451 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11500.3666733 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124290363249 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3461 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11500.6302399 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124319611247 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3471 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11498.9655065 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124347127255 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3481 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11495.8474611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12437214249 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3491 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11492.3859275 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124394795065 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3501 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11489.6926466 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12441577853 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3511 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11488.1360942 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124436644694 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3521 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11487.7905347 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124458359709 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3531 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11488.64127 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12448176508 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3541 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11489.9973793 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124506960351 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3551 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11490.8949174 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124533074212 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3561 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11490.4444242 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124559053717 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3571 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11488.6759239 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12458374682 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3581 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11485.9475819 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124606414471 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11483.0738395 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124626914829 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3601 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11481.0516122 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124645652054 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3611 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11480.0611831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124663707557 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3621 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11480.3099032 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124681971859 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3631 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11481.7426376 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124701248965 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3641 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11483.5384798 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124721705825 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3651 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11485.3795595 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124743083876 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3661 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11485.9724157 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124764697518 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3671 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11485.4924162 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124785629997 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3681 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11483.9556078 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124805166031 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3691 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11481.8515793 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124822954577 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3701 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11480.41003 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124839283865 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3711 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11479.0899328 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124854456848 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3721 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11478.9195658 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124869306914 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3731 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11479.9641142 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124884602405 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3741 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11481.6939677 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124900702383 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3751 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11483.8820377 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124917618158 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3761 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11484.2221402 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124934075679 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3771 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11543.1008514 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124930785533 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3781 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11604.2640169 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124905887763 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3791 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11645.3864858 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12486737523 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3801 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11670.1223068 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124822364149 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3811 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11680.4077698 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124776816079 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3821 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11681.7517705 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124733722344 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3831 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11680.9717479 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124695790211 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3841 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11679.3579735 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124662343557 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3851 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11680.7681591 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124631983954 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3861 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11678.1631847 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124605170316 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3871 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11659.0386532 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124587047827 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3881 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11638.31553 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124576972844 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3891 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11625.0024274 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124571740947 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3901 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11618.3838785 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124568898458 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3911 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11616.5596944 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124567855871 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3921 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11616.3574512 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124567621475 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3931 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11617.5851792 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124569585347 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3941 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11618.3028586 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124574689297 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3951 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11617.8409365 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124583348033 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3961 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11616.2770271 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124596507865 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3971 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11612.9016696 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124613436581 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3981 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11608.3698058 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.12463319014 | 0.1 | 0.0001 -KRATOS_BENCHMARK | Float | Time | 2.3991 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 pressure | 11603.3776533 | 1.0 | 1.0 -KRATOS_BENCHMARK | Float | Node 1 velocity_y | 0.124654602874 | 0.1 | 0.0001 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.cnd b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.cnd deleted file mode 100644 index 46f4148b345a..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.cnd +++ /dev/null @@ -1,1216 +0,0 @@ -BOOK:Nodal Values -NUMBER: 1 CONDITION: point_DISPLACEMENT -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 2 CONDITION: line_DISPLACEMENT -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 3 CONDITION: surface_DISPLACEMENT -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 4 CONDITION: volume_DISPLACEMENT -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 5 CONDITION: point_VELOCITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 6 CONDITION: line_VELOCITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 7 CONDITION: surface_VELOCITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 8 CONDITION: volume_VELOCITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 9 CONDITION: point_MESH_VELOCITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 10 CONDITION: line_MESH_VELOCITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 11 CONDITION: surface_MESH_VELOCITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 12 CONDITION: volume_MESH_VELOCITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 13 CONDITION: point_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 14 CONDITION: line_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 15 CONDITION: surface_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 16 CONDITION: volume_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 17 CONDITION: point_INTERNAL_FRICTION_ANGLE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: INTERNAL_FRICTION_ANGLE -VALUE: 1.0 -END CONDITION -NUMBER: 18 CONDITION: line_INTERNAL_FRICTION_ANGLE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: INTERNAL_FRICTION_ANGLE -VALUE: 1.0 -END CONDITION -NUMBER: 19 CONDITION: surface_INTERNAL_FRICTION_ANGLE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: INTERNAL_FRICTION_ANGLE -VALUE: 1.0 -END CONDITION -NUMBER: 20 CONDITION: volume_INTERNAL_FRICTION_ANGLE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: INTERNAL_FRICTION_ANGLE -VALUE: 1.0 -END CONDITION -NUMBER: 21 CONDITION: point_WATER_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: WATER_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 22 CONDITION: line_WATER_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: WATER_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 23 CONDITION: surface_WATER_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: WATER_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 24 CONDITION: volume_WATER_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: WATER_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 25 CONDITION: point_EXTERNAL_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 26 CONDITION: line_EXTERNAL_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 27 CONDITION: surface_EXTERNAL_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 28 CONDITION: volume_EXTERNAL_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 29 CONDITION: point_IS_INTERFACE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 30 CONDITION: line_IS_INTERFACE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 31 CONDITION: surface_IS_INTERFACE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 32 CONDITION: volume_IS_INTERFACE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 33 CONDITION: point_FLAG_VARIABLE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 34 CONDITION: line_FLAG_VARIABLE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 35 CONDITION: surface_FLAG_VARIABLE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 36 CONDITION: volume_FLAG_VARIABLE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 37 CONDITION: point_IS_BOUNDARY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 38 CONDITION: line_IS_BOUNDARY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 39 CONDITION: surface_IS_BOUNDARY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 40 CONDITION: volume_IS_BOUNDARY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 41 CONDITION: point_IS_FREE_SURFACE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 42 CONDITION: line_IS_FREE_SURFACE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 43 CONDITION: surface_IS_FREE_SURFACE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 44 CONDITION: volume_IS_FREE_SURFACE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 45 CONDITION: point_IS_EROSIONABLE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_EROSIONABLE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 46 CONDITION: line_IS_EROSIONABLE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_EROSIONABLE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 47 CONDITION: surface_IS_EROSIONABLE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_EROSIONABLE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 48 CONDITION: volume_IS_EROSIONABLE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_EROSIONABLE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 49 CONDITION: point_IS_STRUCTURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 50 CONDITION: line_IS_STRUCTURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 51 CONDITION: surface_IS_STRUCTURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 52 CONDITION: volume_IS_STRUCTURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -BOOK:Elements -NUMBER: 53 CONDITION: surface_Fluid2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 54 CONDITION: surface_ASGS2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 55 CONDITION: surface_NoNewtonianASGS2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 56 CONDITION: volume_NoNewtonianASGS3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 57 CONDITION: volume_Fluid3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 58 CONDITION: volume_ASGS3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 59 CONDITION: surface_Fluid2DCoupled -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 60 CONDITION: volume_Fluid3DCoupled -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -BOOK:Conditions -NUMBER: 61 CONDITION: line_Condition2D -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 62 CONDITION: surface_Condition3D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 63 CONDITION: line_Fluid2DNeumann -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 64 CONDITION: surface_Fluid3DNeumann -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -BOOK:Model Parts -NUMBER: 65 CONDITION: point_WallBoundary -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -QUESTION: BEGINDISPLACEMENT -VALUE: BEGINDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDDISPLACEMENT -VALUE: ENDDISPLACEMENT -STATE: HIDDEN -QUESTION: BEGINIS_STRUCTURE -VALUE: BEGINIS_STRUCTURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_STRUCTURE -VALUE: ENDIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 66 CONDITION: line_WallBoundary -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -QUESTION: BEGINDISPLACEMENT -VALUE: BEGINDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDDISPLACEMENT -VALUE: ENDDISPLACEMENT -STATE: HIDDEN -QUESTION: BEGINIS_STRUCTURE -VALUE: BEGINIS_STRUCTURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_STRUCTURE -VALUE: ENDIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 67 CONDITION: surface_WallBoundary -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -QUESTION: BEGINDISPLACEMENT -VALUE: BEGINDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDDISPLACEMENT -VALUE: ENDDISPLACEMENT -STATE: HIDDEN -QUESTION: BEGINIS_STRUCTURE -VALUE: BEGINIS_STRUCTURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_STRUCTURE -VALUE: ENDIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 68 CONDITION: point_FreeSurfaceBoundary -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINIS_FREE_SURFACE -VALUE: BEGINIS_FREE_SURFACE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_FREE_SURFACE -VALUE: ENDIS_FREE_SURFACE -STATE: HIDDEN -END CONDITION -NUMBER: 69 CONDITION: line_FreeSurfaceBoundary -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINIS_FREE_SURFACE -VALUE: BEGINIS_FREE_SURFACE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_FREE_SURFACE -VALUE: ENDIS_FREE_SURFACE -STATE: HIDDEN -END CONDITION -NUMBER: 70 CONDITION: surface_FreeSurfaceBoundary -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINIS_FREE_SURFACE -VALUE: BEGINIS_FREE_SURFACE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_FREE_SURFACE -VALUE: ENDIS_FREE_SURFACE -STATE: HIDDEN -END CONDITION -BOOK:Default -NUMBER: 71 CONDITION: point_Boundary -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DCondition2D -VALUE: BEGIN2DCondition2D -STATE: HIDDEN -QUESTION: END2DCondition2D -VALUE: END2DCondition2D -STATE: HIDDEN -QUESTION: BEGIN3DCondition3D -VALUE: BEGIN3DCondition3D -STATE: HIDDEN -QUESTION: END3DCondition3D -VALUE: END3DCondition3D -STATE: HIDDEN -QUESTION: BEGIN2DIS_BOUNDARY -VALUE: BEGIN2DIS_BOUNDARY -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: IS_BOUNDARY#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_BOUNDARY -VALUE: END2DIS_BOUNDARY -STATE: HIDDEN -END CONDITION -NUMBER: 72 CONDITION: line_Boundary -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DCondition2D -VALUE: BEGIN2DCondition2D -STATE: HIDDEN -QUESTION: END2DCondition2D -VALUE: END2DCondition2D -STATE: HIDDEN -QUESTION: BEGIN3DCondition3D -VALUE: BEGIN3DCondition3D -STATE: HIDDEN -QUESTION: END3DCondition3D -VALUE: END3DCondition3D -STATE: HIDDEN -QUESTION: BEGIN2DIS_BOUNDARY -VALUE: BEGIN2DIS_BOUNDARY -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: IS_BOUNDARY#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_BOUNDARY -VALUE: END2DIS_BOUNDARY -STATE: HIDDEN -END CONDITION -NUMBER: 73 CONDITION: surface_Boundary -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DCondition2D -VALUE: BEGIN2DCondition2D -STATE: HIDDEN -QUESTION: END2DCondition2D -VALUE: END2DCondition2D -STATE: HIDDEN -QUESTION: BEGIN3DCondition3D -VALUE: BEGIN3DCondition3D -STATE: HIDDEN -QUESTION: END3DCondition3D -VALUE: END3DCondition3D -STATE: HIDDEN -QUESTION: BEGIN2DIS_BOUNDARY -VALUE: BEGIN2DIS_BOUNDARY -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: IS_BOUNDARY#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_BOUNDARY -VALUE: END2DIS_BOUNDARY -STATE: HIDDEN -END CONDITION diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.cond b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.cond deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.elem b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.elem deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.geo b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.geo deleted file mode 100644 index 8eaff1780f13..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.geo and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.info b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.info deleted file mode 100644 index 032fb48c2985..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.info +++ /dev/null @@ -1,285318 +0,0 @@ -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: False -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosMKLSolversApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -Import_FluidDynamicsApplication: False -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: True -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: True -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -Import_FluidDynamicsApplication: False -importing KratosIncompressibleFluidApplication ... -KratosIncompressibleFluidApplication lib loaded -KratosIncompressibleFluidApplication application created -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing KratosIncompressibleFluidApplication... -Initializing KratosIncompressibleFluidApplication...Register completed -Initializing KratosIncompressibleFluidApplication...variables succesfully registered -Initializing KratosIncompressibleFluidApplication...elements succesfully registered -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosIncompressibleFluidApplication Succesfully imported -importing KratosPFEMApplication ... -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing Kratos PFEMApplication... -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosPFEMApplication Succesfully imported -importing KratosMeshingApplication ... -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing Kratos MeshingApplication... -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosMeshingApplication sucessfully imported -variables for the edgebased incompressible fluid solver added correctly -variables for the dynamic structural solution added correctly -Coupled_slope2dNonNewt opened for io -Coupled_slope2dNonNewt.node opened for io -Coupled_slope2dNonNewt.prop opened for io -Coupled_slope2dNonNewt.elem opened for io -Coupled_slope2dNonNewt.cond opened for io -Coupled_slope2dNonNewt.init opened for io -initializing result files - Reading Nodes : 114 nodes read - Reading Elements : 123 NoNewtonianASGS2D read -lines read : 834 -pfem model read correctly - Reading Nodes : 691 nodes read - Reading Elements : 1265 Fluid2D read -lines read : 2287 -fixed model read correctly -entered in EdgeBasedLevelSetSolver python constructor -entered in EdgeBasedLevelSetSolver initialize -entered in EdgeBasedLevelSetSolver python constructor -###################### max distance = 0.52846002091 -in 138 -nneg= 41 -npos= 650 -in 128 -nneg= 41 -npos= 650 -dimension in distance computation 2 -elements_to_solve.size() : 17 -********************************************** -finished EdgeBasedLevelSetSolver initialize -dofs for the monolithic solver added correctly -using the velocity Bossak Time Integration Scheme -SuperLU solver finished. - -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -1e-05 -******** CURRENT TIME = 1e-05 -step finished -1e-05 -******** CURRENT TIME = 2e-05 -step finished -1e-05 -******** CURRENT TIME = 3e-05 -step finished -1e-05 -******** CURRENT TIME = 4e-05 -step finished -1e-05 -******** CURRENT TIME = 5e-05 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 194.454 - Final Residual ratio : 0.0696975 - Residual ratio : 0.000358428 - Slope : -16.1987 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -1e-05 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 5e-05 - DELTA_TIME : 1e-05 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -1e-05 -******** CURRENT TIME = 6e-05 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 370.345 - Final Residual ratio : 0.263263 - Residual ratio : 0.000710858 - Slope : -30.8402 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -1e-05 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 6e-05 - DELTA_TIME : 1e-05 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -1e-05 -******** CURRENT TIME = 7e-05 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 420.467 - Final Residual ratio : 0.241276 - Residual ratio : 0.000573829 - Slope : -35.0188 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -1e-05 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 7e-05 - DELTA_TIME : 1e-05 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -1e-05 -******** CURRENT TIME = 8e-05 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 428.501 - Final Residual ratio : 0.289881 - Residual ratio : 0.0006765 - Slope : -38.9282 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -1e-05 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 8e-05 - DELTA_TIME : 1e-05 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -1e-05 -******** CURRENT TIME = 9e-05 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 432.593 - Final Residual ratio : 0.229056 - Residual ratio : 0.000529496 - Slope : -36.0304 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -1e-05 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 9e-05 - DELTA_TIME : 1e-05 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -1e-05 -******** CURRENT TIME = 0.0001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 444.003 - Final Residual ratio : 0.174135 - Residual ratio : 0.000392194 - Slope : -36.9857 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -1e-05 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0001 - DELTA_TIME : 1e-05 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 324.65 - Final Residual ratio : 0.126202 - Residual ratio : 0.000388734 - Slope : -27.0437 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 268.08 - Final Residual ratio : 0.215858 - Residual ratio : 0.000805202 - Slope : -26.7864 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 585.189 - Final Residual ratio : 0.234227 - Residual ratio : 0.000400259 - Slope : -48.7462 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 845.375 - Final Residual ratio : 0.212533 - Residual ratio : 0.000251407 - Slope : -70.4302 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 795.206 - Final Residual ratio : 0.466431 - Residual ratio : 0.000586554 - Slope : -66.2283 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0051 - DELTA_TIME : 0.0051 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 1 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000653028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.065320e+05 Mflops = 345.40 -Solve time = 0.00 -Solve flops = 1.792200e+04 Mflops = 458.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1; expected ratio = 0.0001obtained abs = 0.000598956; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1; expected ratio = 0.001obtained abs = 279.278; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00048399 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.785040e+05 Mflops = 319.82 -Solve time = 0.00 -Solve flops = 1.648400e+04 Mflops = 483.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.73495; expected ratio = 0.0001obtained abs = 0.000390928; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100201; expected ratio = 0.001obtained abs = 28.4921; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.797720e+05 Mflops = 329.84 -Solve time = 0.00 -Solve flops = 1.655000e+04 Mflops = 485.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.996371; expected ratio = 0.0001obtained abs = 0.000113347; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.141935; expected ratio = 0.001obtained abs = 43.9828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.797720e+05 Mflops = 331.58 -Solve time = 0.00 -Solve flops = 1.655000e+04 Mflops = 503.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.760239; expected ratio = 0.0001obtained abs = 4.94268e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.596759; expected ratio = 0.001obtained abs = 165.294; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.797720e+05 Mflops = 330.42 -Solve time = 0.00 -Solve flops = 1.655000e+04 Mflops = 485.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.707255; expected ratio = 0.0001obtained abs = 2.71059e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.534587; expected ratio = 0.001obtained abs = 167.325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.797720e+05 Mflops = 328.69 -Solve time = 0.00 -Solve flops = 1.655000e+04 Mflops = 485.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.817359; expected ratio = 0.0001obtained abs = 1.74795e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.227477; expected ratio = 0.001obtained abs = 67.6167; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.797720e+05 Mflops = 329.27 -Solve time = 0.00 -Solve flops = 1.655000e+04 Mflops = 488.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.09067; expected ratio = 0.0001obtained abs = 1.1389e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.236307; expected ratio = 0.001obtained abs = 75.8877; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805740e+05 Mflops = 331.31 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 486.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.85618; expected ratio = 0.0001obtained abs = 8.85432e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19736; expected ratio = 0.001obtained abs = 63.7492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801000e+05 Mflops = 334.10 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 518.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.579788; expected ratio = 0.0001obtained abs = 8.97758e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.162162; expected ratio = 0.001obtained abs = 52.3247; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 330.24 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 488.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.26084; expected ratio = 0.0001obtained abs = 4.77916e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0800551; expected ratio = 0.001obtained abs = 26.4484; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000495911 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 329.67 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.205579; expected ratio = 0.0001obtained abs = 3.29646e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0405237; expected ratio = 0.001obtained abs = 13.1851; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 330.24 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 499.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.116562; expected ratio = 0.0001obtained abs = 2.04653e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0235841; expected ratio = 0.001obtained abs = 7.72401; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 330.24 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 488.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0877222; expected ratio = 0.0001obtained abs = 1.4401e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.014214; expected ratio = 0.001obtained abs = 4.63987; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 325.54 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.050969; expected ratio = 0.0001obtained abs = 8.70734e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.009144; expected ratio = 0.001obtained abs = 2.99235; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 618.315 - Final Residual ratio : 0.602117 - Residual ratio : 0.000973802 - Slope : -51.4761 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 570.794 - Final Residual ratio : 0.489328 - Residual ratio : 0.000857276 - Slope : -57.0305 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 575.924 - Final Residual ratio : 0.243667 - Residual ratio : 0.000423089 - Slope : -47.9734 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 487.584 - Final Residual ratio : 0.184852 - Residual ratio : 0.000379117 - Slope : -40.6166 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 528.14 - Final Residual ratio : 0.370328 - Residual ratio : 0.000701192 - Slope : -43.9808 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 638.722 - Final Residual ratio : 0.357649 - Residual ratio : 0.000559944 - Slope : -53.197 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 653.054 - Final Residual ratio : 0.405052 - Residual ratio : 0.000620243 - Slope : -54.3874 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 603.324 - Final Residual ratio : 0.324237 - Residual ratio : 0.000537418 - Slope : -50.25 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 470.382 - Final Residual ratio : 0.241535 - Residual ratio : 0.000513486 - Slope : -39.1784 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 334.982 - Final Residual ratio : 0.271954 - Residual ratio : 0.000811847 - Slope : -30.4282 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 14 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 324.28 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 475.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0312789; expected ratio = 0.0001obtained abs = 5.24038e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105733; expected ratio = 0.001obtained abs = 3.46151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 351.775 - Final Residual ratio : 0.213797 - Residual ratio : 0.000607766 - Slope : -31.9601 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 552.262 - Final Residual ratio : 0.547438 - Residual ratio : 0.000991266 - Slope : -50.1558 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 615.515 - Final Residual ratio : 0.613526 - Residual ratio : 0.000996768 - Slope : -55.9002 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 542.034 - Final Residual ratio : 0.259786 - Residual ratio : 0.000479279 - Slope : -45.1478 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 475.174 - Final Residual ratio : 0.217288 - Residual ratio : 0.00045728 - Slope : -39.5797 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 457.361 - Final Residual ratio : 0.390418 - Residual ratio : 0.000853631 - Slope : -41.5428 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 401.825 - Final Residual ratio : 0.269817 - Residual ratio : 0.000671478 - Slope : -33.463 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 349.352 - Final Residual ratio : 0.122387 - Residual ratio : 0.000350327 - Slope : -29.1024 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 387.594 - Final Residual ratio : 0.249095 - Residual ratio : 0.000642669 - Slope : -32.2787 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 420.313 - Final Residual ratio : 0.242621 - Residual ratio : 0.000577238 - Slope : -35.0059 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 330.24 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0199027; expected ratio = 0.0001obtained abs = 3.37102e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00987968; expected ratio = 0.001obtained abs = 3.2319; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 417.476 - Final Residual ratio : 0.217597 - Residual ratio : 0.00052122 - Slope : -34.7716 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 401.079 - Final Residual ratio : 0.141046 - Residual ratio : 0.000351667 - Slope : -33.4115 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 336.756 - Final Residual ratio : 0.243671 - Residual ratio : 0.000723584 - Slope : -30.5921 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 253.843 - Final Residual ratio : 0.212721 - Residual ratio : 0.000838003 - Slope : -23.0573 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 324.298 - Final Residual ratio : 0.291991 - Residual ratio : 0.000900377 - Slope : -29.4551 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 444.658 - Final Residual ratio : 0.140784 - Residual ratio : 0.000316613 - Slope : -37.0431 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0321 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 549.062 - Final Residual ratio : 0.27951 - Residual ratio : 0.000509068 - Slope : -45.7319 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 417.694 - Final Residual ratio : 0.265425 - Residual ratio : 0.000635455 - Slope : -37.948 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 417.806 - Final Residual ratio : 0.173507 - Residual ratio : 0.000415282 - Slope : -34.8027 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 378.933 - Final Residual ratio : 0.160345 - Residual ratio : 0.000423147 - Slope : -42.0859 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 329.67 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 488.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0121005; expected ratio = 0.0001obtained abs = 2.03267e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00384598; expected ratio = 0.001obtained abs = 1.25784; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 374.49 - Final Residual ratio : 0.164419 - Residual ratio : 0.000439049 - Slope : -28.7943 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 378.567 - Final Residual ratio : 0.293978 - Residual ratio : 0.000776554 - Slope : -31.5227 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 385.358 - Final Residual ratio : 0.298176 - Residual ratio : 0.000773763 - Slope : -32.0883 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 384.95 - Final Residual ratio : 0.369263 - Residual ratio : 0.00095925 - Slope : -32.0484 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0401 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 314.337 - Final Residual ratio : 0.0655071 - Residual ratio : 0.000208398 - Slope : -26.1893 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0411 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 289.106 - Final Residual ratio : 0.22742 - Residual ratio : 0.000786633 - Slope : -36.1098 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 338.645 - Final Residual ratio : 0.0868169 - Residual ratio : 0.000256365 - Slope : -26.043 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 390.733 - Final Residual ratio : 0.348243 - Residual ratio : 0.000891255 - Slope : -30.0296 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 338.814 - Final Residual ratio : 0.126182 - Residual ratio : 0.000372423 - Slope : -24.192 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 271.751 - Final Residual ratio : 0.163979 - Residual ratio : 0.000603417 - Slope : -20.8913 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 326.10 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00741777; expected ratio = 0.0001obtained abs = 1.25269e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00343792; expected ratio = 0.001obtained abs = 1.12517; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 279.123 - Final Residual ratio : 0.140039 - Residual ratio : 0.00050171 - Slope : -19.9273 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 314.953 - Final Residual ratio : 0.121938 - Residual ratio : 0.000387162 - Slope : -22.4879 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 313.291 - Final Residual ratio : 0.158179 - Residual ratio : 0.000504894 - Slope : -22.3667 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 282.396 - Final Residual ratio : 0.173552 - Residual ratio : 0.000614568 - Slope : -20.1587 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 234.487 - Final Residual ratio : 0.098665 - Residual ratio : 0.00042077 - Slope : -16.742 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 189.959 - Final Residual ratio : 0.146819 - Residual ratio : 0.000772899 - Slope : -15.8177 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 194.257 - Final Residual ratio : 0.0471448 - Residual ratio : 0.000242693 - Slope : -13.8721 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 234.24 - Final Residual ratio : 0.108851 - Residual ratio : 0.0004647 - Slope : -16.7236 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 272.273 - Final Residual ratio : 0.252228 - Residual ratio : 0.000926381 - Slope : -18.1347 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 227.101 - Final Residual ratio : 0.181721 - Residual ratio : 0.000800176 - Slope : -17.4553 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 326.10 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00601752; expected ratio = 0.0001obtained abs = 1.01411e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0054558; expected ratio = 0.001obtained abs = 1.7864; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 172.433 - Final Residual ratio : 0.0545242 - Residual ratio : 0.000316205 - Slope : -12.3127 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 164.15 - Final Residual ratio : 0.117141 - Residual ratio : 0.00071362 - Slope : -11.7166 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 184.077 - Final Residual ratio : 0.0496699 - Residual ratio : 0.000269833 - Slope : -13.1448 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 194.63 - Final Residual ratio : 0.102185 - Residual ratio : 0.000525022 - Slope : -13.8948 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 184.603 - Final Residual ratio : 0.120971 - Residual ratio : 0.000655306 - Slope : -13.1773 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 157.754 - Final Residual ratio : 0.145661 - Residual ratio : 0.000923342 - Slope : -12.1237 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 129.305 - Final Residual ratio : 0.100579 - Residual ratio : 0.000777847 - Slope : -10.767 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 126.295 - Final Residual ratio : 0.0328408 - Residual ratio : 0.000260032 - Slope : -9.01874 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 145.079 - Final Residual ratio : 0.043755 - Residual ratio : 0.000301594 - Slope : -10.3597 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 152.872 - Final Residual ratio : 0.0582987 - Residual ratio : 0.000381356 - Slope : -10.9153 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 329.09 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00290088; expected ratio = 0.0001obtained abs = 4.89756e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00369824; expected ratio = 0.001obtained abs = 1.21068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 137.319 - Final Residual ratio : 0.125374 - Residual ratio : 0.000913012 - Slope : -10.5534 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 113.876 - Final Residual ratio : 0.0404128 - Residual ratio : 0.000354884 - Slope : -8.13112 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 106.79 - Final Residual ratio : 0.0655163 - Residual ratio : 0.000613504 - Slope : -7.62319 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 114.88 - Final Residual ratio : 0.0329832 - Residual ratio : 0.000287109 - Slope : -8.20339 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 119.773 - Final Residual ratio : 0.0319332 - Residual ratio : 0.000266615 - Slope : -8.55291 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0711 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 122.814 - Final Residual ratio : 0.0997007 - Residual ratio : 0.000811803 - Slope : -8.76531 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 103.529 - Final Residual ratio : 0.0972513 - Residual ratio : 0.000939365 - Slope : -7.95627 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 83.2811 - Final Residual ratio : 0.0800794 - Residual ratio : 0.000961556 - Slope : -6.93342 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 81.2941 - Final Residual ratio : 0.0483926 - Residual ratio : 0.000595279 - Slope : -5.80326 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 91.0305 - Final Residual ratio : 0.0837852 - Residual ratio : 0.000920408 - Slope : -6.9959 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 329.67 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00265405; expected ratio = 0.0001obtained abs = 4.47794e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0065354; expected ratio = 0.001obtained abs = 2.13868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 93.8666 - Final Residual ratio : 0.0818954 - Residual ratio : 0.000872465 - Slope : -7.21421 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 83.2643 - Final Residual ratio : 0.0697727 - Residual ratio : 0.000837967 - Slope : -6.39958 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 73.0241 - Final Residual ratio : 0.0538463 - Residual ratio : 0.000737377 - Slope : -6.63366 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.3434 - Final Residual ratio : 0.0319803 - Residual ratio : 0.000482042 - Slope : -4.42076 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 215.573 - Final Residual ratio : 0.1369 - Residual ratio : 0.000635053 - Slope : -14.3624 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 106.685 - Final Residual ratio : 0.0625232 - Residual ratio : 0.000586056 - Slope : -7.10815 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 85.5235 - Final Residual ratio : 0.0715995 - Residual ratio : 0.000837191 - Slope : -5.34074 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 61.0748 - Final Residual ratio : 0.0601636 - Residual ratio : 0.00098508 - Slope : -4.35819 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0841 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.8687 - Final Residual ratio : 0.0298313 - Residual ratio : 0.000610437 - Slope : -3.75684 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.8095 - Final Residual ratio : 0.0127258 - Residual ratio : 0.000255489 - Slope : -3.1123 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 326.66 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 488.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000986586; expected ratio = 0.0001obtained abs = 1.66544e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000874032; expected ratio = 0.001obtained abs = 0.285937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 57.5189 - Final Residual ratio : 0.0190636 - Residual ratio : 0.000331432 - Slope : -3.83332 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 62.0622 - Final Residual ratio : 0.037519 - Residual ratio : 0.000604538 - Slope : -4.13498 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.8849 - Final Residual ratio : 0.0638358 - Residual ratio : 0.000888028 - Slope : -5.13008 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.7914 - Final Residual ratio : 0.0271352 - Residual ratio : 0.000634126 - Slope : -2.85095 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.4428 - Final Residual ratio : 0.0178003 - Residual ratio : 0.000463034 - Slope : -2.56167 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0911 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 47.1559 - Final Residual ratio : 0.0442076 - Residual ratio : 0.000937478 - Slope : -3.36512 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.8946 - Final Residual ratio : 0.0410788 - Residual ratio : 0.000776615 - Slope : -4.06566 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.7084 - Final Residual ratio : 0.0145036 - Residual ratio : 0.000291774 - Slope : -4.51763 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 94.8952 - Final Residual ratio : 0.0717623 - Residual ratio : 0.000756227 - Slope : -6.7731 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.0029 - Final Residual ratio : 0.0602512 - Residual ratio : 0.000700571 - Slope : -6.61097 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.0951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.0951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 329.67 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 488.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00137941; expected ratio = 0.0001obtained abs = 2.32833e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00150202; expected ratio = 0.001obtained abs = 0.491524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.0961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.4883 - Final Residual ratio : 0.0159611 - Residual ratio : 0.000322522 - Slope : -3.29816 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0971 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.1592 - Final Residual ratio : 0.0152769 - Residual ratio : 0.000380407 - Slope : -2.67626 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.1307 - Final Residual ratio : 0.0188962 - Residual ratio : 0.0004829 - Slope : -2.60746 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.0991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.3914 - Final Residual ratio : 0.0339601 - Residual ratio : 0.000987457 - Slope : -2.64288 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.0991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.4993 - Final Residual ratio : 0.0223571 - Residual ratio : 0.000784482 - Slope : -2.03406 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 0.1011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.2765 - Final Residual ratio : 0.021859 - Residual ratio : 0.000773044 - Slope : -2.01819 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1021 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.797 - Final Residual ratio : 0.0316645 - Residual ratio : 0.000965471 - Slope : -2.34038 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.364 - Final Residual ratio : 0.033914 - Residual ratio : 0.000958999 - Slope : -2.35534 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.8015 - Final Residual ratio : 0.0263887 - Residual ratio : 0.000804495 - Slope : -2.18501 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1051 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 120.234 - Final Residual ratio : 0.0523315 - Residual ratio : 0.000435246 - Slope : -7.51137 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 331.41 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000406819; expected ratio = 0.0001obtained abs = 6.86787e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000534409; expected ratio = 0.001obtained abs = 0.17487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.6515 - Final Residual ratio : 0.0330309 - Residual ratio : 0.00062735 - Slope : -3.5079 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.7676 - Final Residual ratio : 0.0231794 - Residual ratio : 0.000729656 - Slope : -2.26746 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.7637 - Final Residual ratio : 0.0172701 - Residual ratio : 0.000670325 - Slope : -1.60915 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.5627 - Final Residual ratio : 0.0146017 - Residual ratio : 0.000571211 - Slope : -1.59676 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.0228 - Final Residual ratio : 0.0157308 - Residual ratio : 0.000542017 - Slope : -1.81294 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1111 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.4635 - Final Residual ratio : 0.0103033 - Residual ratio : 0.000458666 - Slope : -1.49688 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.7574 - Final Residual ratio : 0.0171941 - Residual ratio : 0.000828335 - Slope : -1.38268 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.2531 - Final Residual ratio : 0.0111027 - Residual ratio : 0.000477471 - Slope : -1.36717 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.1846 - Final Residual ratio : 0.0222247 - Residual ratio : 0.000918963 - Slope : -1.72588 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.3768 - Final Residual ratio : 0.0218929 - Residual ratio : 0.000978375 - Slope : -1.49032 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 338.40 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00109763; expected ratio = 0.0001obtained abs = 1.85328e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00135632; expected ratio = 0.001obtained abs = 0.443898; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.857 - Final Residual ratio : 0.0150211 - Residual ratio : 0.000841189 - Slope : -1.18947 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.5701 - Final Residual ratio : 0.00744686 - Residual ratio : 0.000511106 - Slope : -0.970844 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1181 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.0206 - Final Residual ratio : 0.0131258 - Residual ratio : 0.000873853 - Slope : -1.15442 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.7399 - Final Residual ratio : 0.00804356 - Residual ratio : 0.000480503 - Slope : -1.04574 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.8947 - Final Residual ratio : 0.0045163 - Residual ratio : 0.000267321 - Slope : -1.05563 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.236 - Final Residual ratio : 0.0118093 - Residual ratio : 0.000775089 - Slope : -1.01495 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.8088 - Final Residual ratio : 0.00928712 - Residual ratio : 0.000672549 - Slope : -0.985682 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.5702 - Final Residual ratio : 0.0112636 - Residual ratio : 0.000773062 - Slope : -0.970593 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.4997 - Final Residual ratio : 0.00996701 - Residual ratio : 0.000424134 - Slope : -1.38175 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 108.369 - Final Residual ratio : 0.0831362 - Residual ratio : 0.000767162 - Slope : -7.21902 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 338.25 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 488.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00158836; expected ratio = 0.0001obtained abs = 2.68274e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00206927; expected ratio = 0.001obtained abs = 0.677365; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 53.8449 - Final Residual ratio : 0.0449063 - Residual ratio : 0.000833993 - Slope : -3.3625 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.3927 - Final Residual ratio : 0.0198895 - Residual ratio : 0.000676683 - Slope : -1.95819 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.1128 - Final Residual ratio : 0.0148175 - Residual ratio : 0.000775268 - Slope : -1.19362 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.7436 - Final Residual ratio : 0.00906954 - Residual ratio : 0.000615152 - Slope : -0.920907 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.8122 - Final Residual ratio : 0.00508229 - Residual ratio : 0.000367957 - Slope : -0.986222 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8929 - Final Residual ratio : 0.00391561 - Residual ratio : 0.000303703 - Slope : -0.758175 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.3332 - Final Residual ratio : 0.00419694 - Residual ratio : 0.000340297 - Slope : -0.725233 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.503 - Final Residual ratio : 0.0115323 - Residual ratio : 0.000922359 - Slope : -0.780719 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4099 - Final Residual ratio : 0.00558895 - Residual ratio : 0.000416778 - Slope : -0.893622 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.4408 - Final Residual ratio : 0.00765012 - Residual ratio : 0.000529756 - Slope : -0.849011 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 326.10 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00259178; expected ratio = 0.0001obtained abs = 4.37966e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00293869; expected ratio = 0.001obtained abs = 0.962307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.8983 - Final Residual ratio : 0.00911214 - Residual ratio : 0.000655631 - Slope : -0.81701 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.9004 - Final Residual ratio : 0.00759541 - Residual ratio : 0.000588772 - Slope : -0.920916 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.8915 - Final Residual ratio : 0.0112486 - Residual ratio : 0.000945935 - Slope : -0.792019 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1391 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.559 - Final Residual ratio : 0.00649368 - Residual ratio : 0.000561788 - Slope : -0.679556 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0813 - Final Residual ratio : 0.0078409 - Residual ratio : 0.000649013 - Slope : -0.928725 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9404 - Final Residual ratio : 0.00783775 - Residual ratio : 0.000656408 - Slope : -0.701914 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.7766 - Final Residual ratio : 0.00628853 - Residual ratio : 0.000533983 - Slope : -0.692374 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.6014 - Final Residual ratio : 0.0114656 - Residual ratio : 0.000988301 - Slope : -0.724369 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.7582 - Final Residual ratio : 0.00786914 - Residual ratio : 0.000669247 - Slope : -0.734395 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.4059 - Final Residual ratio : 0.00728316 - Residual ratio : 0.000587073 - Slope : -0.774912 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 334.05 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00266342; expected ratio = 0.0001obtained abs = 4.50233e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00295369; expected ratio = 0.001obtained abs = 0.96753; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.3894 - Final Residual ratio : 0.00617028 - Residual ratio : 0.00049803 - Slope : -0.825548 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.2446 - Final Residual ratio : 0.00763933 - Residual ratio : 0.000623892 - Slope : -0.764813 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.8933 - Final Residual ratio : 0.00821037 - Residual ratio : 0.000690338 - Slope : -0.699121 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.6496 - Final Residual ratio : 0.0110381 - Residual ratio : 0.000947505 - Slope : -0.727412 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.8479 - Final Residual ratio : 0.0100831 - Residual ratio : 0.000851049 - Slope : -0.69634 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 145.543 - Final Residual ratio : 0.085866 - Residual ratio : 0.000589969 - Slope : -9.09109 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 106.888 - Final Residual ratio : 0.0859591 - Residual ratio : 0.000804194 - Slope : -7.12017 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.4853 - Final Residual ratio : 0.0225051 - Residual ratio : 0.00056996 - Slope : -2.32134 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.3037 - Final Residual ratio : 0.0258508 - Residual ratio : 0.000712071 - Slope : -2.13399 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.5995 - Final Residual ratio : 0.0134094 - Residual ratio : 0.00068417 - Slope : -1.15212 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 339.62 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000992463; expected ratio = 0.0001obtained abs = 1.67782e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00207196; expected ratio = 0.001obtained abs = 0.678706; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.979 - Final Residual ratio : 0.0142947 - Residual ratio : 0.000954317 - Slope : -0.935292 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.0215 - Final Residual ratio : 0.00903925 - Residual ratio : 0.000694178 - Slope : -0.81328 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.7521 - Final Residual ratio : 0.00792877 - Residual ratio : 0.00067467 - Slope : -0.903396 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.0914 - Final Residual ratio : 0.0088595 - Residual ratio : 0.000798772 - Slope : -0.692659 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 12 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.9313 - Final Residual ratio : 0.0353321 - Residual ratio : 0.00090755 - Slope : -3.8896 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.5919 - Final Residual ratio : 0.00769364 - Residual ratio : 0.000566047 - Slope : -0.799068 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 309.864 - Final Residual ratio : 0.266178 - Residual ratio : 0.000859018 - Slope : -19.3498 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 73.2076 - Final Residual ratio : 0.032878 - Residual ratio : 0.000449106 - Slope : -4.3044 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 60.6933 - Final Residual ratio : 0.0312511 - Residual ratio : 0.000514902 - Slope : -3.79138 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 83.9606 - Final Residual ratio : 0.0441082 - Residual ratio : 0.000525344 - Slope : -4.93626 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 336.44 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000505704; expected ratio = 0.0001obtained abs = 8.54924e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000557896; expected ratio = 0.001obtained abs = 0.182756; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.7958 - Final Residual ratio : 0.0164799 - Residual ratio : 0.000502501 - Slope : -1.9282 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.9345 - Final Residual ratio : 0.0191457 - Residual ratio : 0.000914555 - Slope : -1.30721 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.2685 - Final Residual ratio : 0.0143396 - Residual ratio : 0.000939161 - Slope : -0.953385 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.1297 - Final Residual ratio : 0.0119137 - Residual ratio : 0.000982191 - Slope : -0.757362 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4777 - Final Residual ratio : 0.0103349 - Residual ratio : 0.000986367 - Slope : -0.697824 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.87785 - Final Residual ratio : 0.0030107 - Residual ratio : 0.000304793 - Slope : -0.617177 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.2437 - Final Residual ratio : 0.0148809 - Residual ratio : 0.000773289 - Slope : -1.13111 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4807 - Final Residual ratio : 0.00664062 - Residual ratio : 0.000633604 - Slope : -0.616122 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.35701 - Final Residual ratio : 0.00350595 - Residual ratio : 0.000374687 - Slope : -0.519639 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.76144 - Final Residual ratio : 0.00677099 - Residual ratio : 0.000772818 - Slope : -0.48637 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 337.19 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116099; expected ratio = 0.0001obtained abs = 1.96327e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00108882; expected ratio = 0.001obtained abs = 0.356807; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.34148 - Final Residual ratio : 0.00319316 - Residual ratio : 0.000382804 - Slope : -0.490488 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.13564 - Final Residual ratio : 0.00662222 - Residual ratio : 0.000813976 - Slope : -0.508064 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 150.059 - Final Residual ratio : 0.122483 - Residual ratio : 0.000816228 - Slope : -8.81981 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.807 - Final Residual ratio : 0.0547195 - Residual ratio : 0.000630359 - Slope : -5.10307 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.44 - Final Residual ratio : 0.0306935 - Residual ratio : 0.000798477 - Slope : -2.13385 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.0765 - Final Residual ratio : 0.0172747 - Residual ratio : 0.00059411 - Slope : -1.6144 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.2115 - Final Residual ratio : 0.00935088 - Residual ratio : 0.000420992 - Slope : -1.23345 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3239 - Final Residual ratio : 0.0054313 - Residual ratio : 0.000332721 - Slope : -0.90658 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5944 - Final Residual ratio : 0.00485877 - Residual ratio : 0.000419061 - Slope : -0.643864 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.17473 - Final Residual ratio : 0.00481171 - Residual ratio : 0.000588608 - Slope : -0.480583 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 337.04 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 488.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000505557; expected ratio = 0.0001obtained abs = 8.54891e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00034542; expected ratio = 0.001obtained abs = 0.113205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.68217 - Final Residual ratio : 0.0042938 - Residual ratio : 0.000755662 - Slope : -0.354867 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.69903 - Final Residual ratio : 0.0028322 - Residual ratio : 0.000496962 - Slope : -0.335071 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.8648 - Final Residual ratio : 0.0381898 - Residual ratio : 0.000814892 - Slope : -2.60148 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.8327 - Final Residual ratio : 0.0313422 - Residual ratio : 0.000807107 - Slope : -2.15563 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.2695 - Final Residual ratio : 0.0189122 - Residual ratio : 0.000748422 - Slope : -1.48533 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3119 - Final Residual ratio : 0.0101825 - Residual ratio : 0.000624239 - Slope : -0.905652 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.7196 - Final Residual ratio : 0.00703228 - Residual ratio : 0.000656019 - Slope : -0.595144 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.41856 - Final Residual ratio : 0.00482522 - Residual ratio : 0.000573165 - Slope : -0.467429 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.98091 - Final Residual ratio : 0.00702196 - Residual ratio : 0.000879844 - Slope : -0.442994 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.2237 - Final Residual ratio : 0.00530338 - Residual ratio : 0.000644889 - Slope : -0.456578 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.1951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 338.40 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000909002; expected ratio = 0.0001obtained abs = 1.53739e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000848428; expected ratio = 0.001obtained abs = 0.278119; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.1961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.66897 - Final Residual ratio : 0.00628706 - Residual ratio : 0.000819805 - Slope : -0.450746 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.27828 - Final Residual ratio : 0.00464459 - Residual ratio : 0.000638144 - Slope : -0.484909 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.97458 - Final Residual ratio : 0.00509014 - Residual ratio : 0.000729812 - Slope : -0.435593 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.1991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.75163 - Final Residual ratio : 0.00572881 - Residual ratio : 0.000848507 - Slope : -0.421619 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.1991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2001 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.72492 - Final Residual ratio : 0.00230887 - Residual ratio : 0.00034333 - Slope : -0.395448 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 0.2011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.36759 - Final Residual ratio : 0.00517223 - Residual ratio : 0.000812275 - Slope : -0.397651 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2021 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.23663 - Final Residual ratio : 0.00400215 - Residual ratio : 0.000641717 - Slope : -0.366625 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.16757 - Final Residual ratio : 0.00320931 - Residual ratio : 0.000520352 - Slope : -0.36261 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.8619 - Final Residual ratio : 0.0108075 - Residual ratio : 0.000681352 - Slope : -0.932417 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.35377 - Final Residual ratio : 0.00399684 - Residual ratio : 0.00062905 - Slope : -0.373516 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 338.40 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00100679; expected ratio = 0.0001obtained abs = 1.70313e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000981078; expected ratio = 0.001obtained abs = 0.321702; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.66084 - Final Residual ratio : 0.00323375 - Residual ratio : 0.000571249 - Slope : -0.314311 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.1185 - Final Residual ratio : 0.00385616 - Residual ratio : 0.000630246 - Slope : -0.339702 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.10158 - Final Residual ratio : 0.00503512 - Residual ratio : 0.000825215 - Slope : -0.338697 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.03355 - Final Residual ratio : 0.00484206 - Residual ratio : 0.000802522 - Slope : -0.35463 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.96717 - Final Residual ratio : 0.00455891 - Residual ratio : 0.000763998 - Slope : -0.350742 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.87858 - Final Residual ratio : 0.00505461 - Residual ratio : 0.000859834 - Slope : -0.419538 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.85909 - Final Residual ratio : 0.00261113 - Residual ratio : 0.000445655 - Slope : -0.32536 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.86964 - Final Residual ratio : 0.0054845 - Residual ratio : 0.000934384 - Slope : -0.34495 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.8883 - Final Residual ratio : 0.00473414 - Residual ratio : 0.000803992 - Slope : -0.346092 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.80767 - Final Residual ratio : 0.00426778 - Residual ratio : 0.000734852 - Slope : -0.341377 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 339.01 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 488.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.001065; expected ratio = 0.0001obtained abs = 1.80201e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00103401; expected ratio = 0.001obtained abs = 0.339152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.88131 - Final Residual ratio : 0.00568939 - Residual ratio : 0.000967368 - Slope : -0.345624 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.90892 - Final Residual ratio : 0.00286701 - Residual ratio : 0.000485199 - Slope : -0.328114 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.93968 - Final Residual ratio : 0.00395626 - Residual ratio : 0.000666072 - Slope : -0.329762 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.95564 - Final Residual ratio : 0.00486406 - Residual ratio : 0.000816715 - Slope : -0.330598 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.70532 - Final Residual ratio : 0.00311534 - Residual ratio : 0.00054604 - Slope : -0.316789 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.8877 - Final Residual ratio : 0.00435144 - Residual ratio : 0.000739073 - Slope : -0.326853 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.88595 - Final Residual ratio : 0.00366494 - Residual ratio : 0.000622659 - Slope : -0.326793 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.89372 - Final Residual ratio : 0.00276678 - Residual ratio : 0.000469446 - Slope : -0.327275 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.90007 - Final Residual ratio : 0.00223161 - Residual ratio : 0.000378235 - Slope : -0.327658 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.63693 - Final Residual ratio : 0.00474165 - Residual ratio : 0.000841176 - Slope : -0.331305 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 327.80 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 459.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116452; expected ratio = 0.0001obtained abs = 1.9708e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00112676; expected ratio = 0.001obtained abs = 0.369686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.86044 - Final Residual ratio : 0.00213659 - Residual ratio : 0.000364578 - Slope : -0.325461 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.87563 - Final Residual ratio : 0.00274436 - Residual ratio : 0.000467075 - Slope : -0.326271 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.89763 - Final Residual ratio : 0.00351041 - Residual ratio : 0.000595223 - Slope : -0.327451 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.91186 - Final Residual ratio : 0.00427916 - Residual ratio : 0.000723827 - Slope : -0.328199 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.59812 - Final Residual ratio : 0.00328036 - Residual ratio : 0.000585975 - Slope : -0.310825 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.86758 - Final Residual ratio : 0.00469558 - Residual ratio : 0.000800259 - Slope : -0.325716 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.3357 - Final Residual ratio : 0.0316736 - Residual ratio : 0.000785249 - Slope : -2.23911 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.7223 - Final Residual ratio : 0.00515587 - Residual ratio : 0.000405263 - Slope : -0.748066 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.498 - Final Residual ratio : 0.00924263 - Residual ratio : 0.000880415 - Slope : -0.699254 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.17803 - Final Residual ratio : 0.00768395 - Residual ratio : 0.000837211 - Slope : -0.509464 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 337.04 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000936629; expected ratio = 0.0001obtained abs = 1.5854e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000937924; expected ratio = 0.001obtained abs = 0.30779; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.84956 - Final Residual ratio : 0.00613231 - Residual ratio : 0.00078123 - Slope : -0.435746 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.99339 - Final Residual ratio : 0.00501663 - Residual ratio : 0.000717339 - Slope : -0.388243 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.57439 - Final Residual ratio : 0.00557676 - Residual ratio : 0.000848256 - Slope : -0.437921 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.44229 - Final Residual ratio : 0.0031719 - Residual ratio : 0.000492357 - Slope : -0.357729 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.20325 - Final Residual ratio : 0.00294249 - Residual ratio : 0.000474347 - Slope : -0.344462 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.56748 - Final Residual ratio : 0.00481577 - Residual ratio : 0.000733275 - Slope : -0.364592 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.64839 - Final Residual ratio : 0.00541053 - Residual ratio : 0.000813811 - Slope : -0.369054 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2431 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.7087 - Final Residual ratio : 0.00574774 - Residual ratio : 0.000856758 - Slope : -0.372386 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.7219 - Final Residual ratio : 0.00590307 - Residual ratio : 0.000878184 - Slope : -0.373111 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.35299 - Final Residual ratio : 0.00481913 - Residual ratio : 0.000758561 - Slope : -0.352676 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 339.01 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0017345; expected ratio = 0.0001obtained abs = 2.93705e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00154262; expected ratio = 0.001obtained abs = 0.506417; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.64173 - Final Residual ratio : 0.00569708 - Residual ratio : 0.000857771 - Slope : -0.368669 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.59756 - Final Residual ratio : 0.00535809 - Residual ratio : 0.000812131 - Slope : -0.366234 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.57975 - Final Residual ratio : 0.0053186 - Residual ratio : 0.000808329 - Slope : -0.365246 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2491 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.56974 - Final Residual ratio : 0.00532503 - Residual ratio : 0.000810539 - Slope : -0.36469 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.15003 - Final Residual ratio : 0.00418773 - Residual ratio : 0.000680928 - Slope : -0.341436 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 116.49 - Final Residual ratio : 0.104009 - Residual ratio : 0.000892855 - Slope : -6.46589 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.1805 - Final Residual ratio : 0.0203782 - Residual ratio : 0.000653556 - Slope : -1.64001 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.1571 - Final Residual ratio : 0.019317 - Residual ratio : 0.000619989 - Slope : -1.83163 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.388 - Final Residual ratio : 0.00738154 - Residual ratio : 0.000450424 - Slope : -0.862135 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.276 - Final Residual ratio : 0.00451197 - Residual ratio : 0.000400138 - Slope : -0.593238 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453234 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 332.14 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 459.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00115879; expected ratio = 0.0001obtained abs = 1.96272e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00117337; expected ratio = 0.001obtained abs = 0.385274; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.66426 - Final Residual ratio : 0.00519212 - Residual ratio : 0.000537249 - Slope : -0.508372 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.38878 - Final Residual ratio : 0.0067933 - Residual ratio : 0.000809807 - Slope : -0.441157 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.18894 - Final Residual ratio : 0.00208233 - Residual ratio : 0.000289658 - Slope : -0.359343 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.32673 - Final Residual ratio : 0.00313923 - Residual ratio : 0.000496185 - Slope : -0.395225 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.79052 - Final Residual ratio : 0.00505635 - Residual ratio : 0.000873213 - Slope : -0.340321 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.08395 - Final Residual ratio : 0.00578537 - Residual ratio : 0.000950923 - Slope : -0.337676 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.3514 - Final Residual ratio : 0.0127006 - Residual ratio : 0.000594835 - Slope : -1.18549 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.55217 - Final Residual ratio : 0.00461886 - Residual ratio : 0.000611594 - Slope : -0.419308 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.74419 - Final Residual ratio : 0.00416179 - Residual ratio : 0.000724521 - Slope : -0.31889 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2651 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.88178 - Final Residual ratio : 0.00271266 - Residual ratio : 0.000461197 - Slope : -0.326615 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000777006 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 337.79 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00346713; expected ratio = 0.0001obtained abs = 5.8789e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00255879; expected ratio = 0.001obtained abs = 0.840775; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.14416 - Final Residual ratio : 0.00332013 - Residual ratio : 0.000540372 - Slope : -0.341158 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.6668 - Final Residual ratio : 0.0267614 - Residual ratio : 0.000819222 - Slope : -1.81334 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.0789 - Final Residual ratio : 0.0262605 - Residual ratio : 0.000624078 - Slope : -2.21329 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.6125 - Final Residual ratio : 0.0132434 - Residual ratio : 0.000972884 - Slope : -0.849955 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3876 - Final Residual ratio : 0.00855373 - Residual ratio : 0.000823458 - Slope : -0.576613 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.88629 - Final Residual ratio : 0.00710782 - Residual ratio : 0.000799863 - Slope : -0.493288 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.6469 - Final Residual ratio : 0.00295327 - Residual ratio : 0.000386204 - Slope : -0.402313 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.56028 - Final Residual ratio : 0.00266697 - Residual ratio : 0.000406533 - Slope : -0.345138 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.79828 - Final Residual ratio : 0.00336727 - Residual ratio : 0.000580736 - Slope : -0.304995 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.34433 - Final Residual ratio : 0.00315389 - Residual ratio : 0.000590138 - Slope : -0.296732 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 337.79 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00203417; expected ratio = 0.0001obtained abs = 3.4512e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00134354; expected ratio = 0.001obtained abs = 0.441627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.56659 - Final Residual ratio : 0.00221231 - Residual ratio : 0.000397427 - Slope : -0.309132 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.76007 - Final Residual ratio : 0.00272528 - Residual ratio : 0.000473134 - Slope : -0.319853 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.91528 - Final Residual ratio : 0.00317086 - Residual ratio : 0.000536045 - Slope : -0.32845 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.97413 - Final Residual ratio : 0.00330514 - Residual ratio : 0.000553243 - Slope : -0.331712 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.79419 - Final Residual ratio : 0.00324193 - Residual ratio : 0.000559513 - Slope : -0.321719 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.89612 - Final Residual ratio : 0.00482651 - Residual ratio : 0.00081859 - Slope : -0.346547 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.3533 - Final Residual ratio : 0.0468133 - Residual ratio : 0.000948534 - Slope : -2.90038 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.4337 - Final Residual ratio : 0.0161735 - Residual ratio : 0.000720946 - Slope : -1.17987 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.9914 - Final Residual ratio : 0.010084 - Residual ratio : 0.000776203 - Slope : -0.683228 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.01065 - Final Residual ratio : 0.00798551 - Residual ratio : 0.00088623 - Slope : -0.473825 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 339.77 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00253224; expected ratio = 0.0001obtained abs = 4.29628e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00244505; expected ratio = 0.001obtained abs = 0.803616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.69472 - Final Residual ratio : 0.00618821 - Residual ratio : 0.000804215 - Slope : -0.404659 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.50091 - Final Residual ratio : 0.00377742 - Residual ratio : 0.000503594 - Slope : -0.374857 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.44722 - Final Residual ratio : 0.0033606 - Residual ratio : 0.000451256 - Slope : -0.372193 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.0736 - Final Residual ratio : 0.0195134 - Residual ratio : 0.000627975 - Slope : -1.63442 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.1998 - Final Residual ratio : 0.00425957 - Residual ratio : 0.000380324 - Slope : -0.466483 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.85097 - Final Residual ratio : 0.00732502 - Residual ratio : 0.000827595 - Slope : -0.465455 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.23627 - Final Residual ratio : 0.00643013 - Residual ratio : 0.000888597 - Slope : -0.401658 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.89948 - Final Residual ratio : 0.00303603 - Residual ratio : 0.000514626 - Slope : -0.310339 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.01977 - Final Residual ratio : 0.0036448 - Residual ratio : 0.000726089 - Slope : -0.264007 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.49049 - Final Residual ratio : 0.00320948 - Residual ratio : 0.000714727 - Slope : -0.236173 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.2951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 340.39 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0101244; expected ratio = 0.0001obtained abs = 1.72204e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0061921; expected ratio = 0.001obtained abs = 2.03764; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.2961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.31955 - Final Residual ratio : 0.00353731 - Residual ratio : 0.000818907 - Slope : -0.269751 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.35811 - Final Residual ratio : 0.0035366 - Residual ratio : 0.0008115 - Slope : -0.241921 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.50231 - Final Residual ratio : 0.00306406 - Residual ratio : 0.000680552 - Slope : -0.249958 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.2991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.63906 - Final Residual ratio : 0.00357425 - Residual ratio : 0.000770469 - Slope : -0.257527 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.2991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.74048 - Final Residual ratio : 0.00247404 - Residual ratio : 0.000521896 - Slope : -0.249369 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 0.3011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.73976 - Final Residual ratio : 0.0038233 - Residual ratio : 0.000806644 - Slope : -0.24926 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.71947 - Final Residual ratio : 0.00321009 - Residual ratio : 0.000680179 - Slope : -0.235813 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.67915 - Final Residual ratio : 0.00393272 - Residual ratio : 0.000840476 - Slope : -0.292201 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.63456 - Final Residual ratio : 0.00356823 - Residual ratio : 0.000769917 - Slope : -0.257277 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.61686 - Final Residual ratio : 0.0035979 - Residual ratio : 0.000779296 - Slope : -0.271368 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 335.24 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0167429; expected ratio = 0.0001obtained abs = 2.85634e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00809704; expected ratio = 0.001obtained abs = 2.66696; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.57228 - Final Residual ratio : 0.00338439 - Residual ratio : 0.000740197 - Slope : -0.253828 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.56274 - Final Residual ratio : 0.00331986 - Residual ratio : 0.000727603 - Slope : -0.239969 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.56673 - Final Residual ratio : 0.00232389 - Residual ratio : 0.000508874 - Slope : -0.240232 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.57582 - Final Residual ratio : 0.0042433 - Residual ratio : 0.000927331 - Slope : -0.253976 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 13 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.60436 - Final Residual ratio : 0.00458727 - Residual ratio : 0.00099629 - Slope : -0.255543 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.59373 - Final Residual ratio : 0.00275272 - Residual ratio : 0.000599233 - Slope : -0.24163 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.59789 - Final Residual ratio : 0.00365653 - Residual ratio : 0.000795263 - Slope : -0.241802 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3131 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 272.852 - Final Residual ratio : 0.166909 - Residual ratio : 0.000611718 - Slope : -16.0403 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 136.348 - Final Residual ratio : 0.0789776 - Residual ratio : 0.000579236 - Slope : -7.17205 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 68.8787 - Final Residual ratio : 0.0673402 - Residual ratio : 0.000977664 - Slope : -4.30071 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 339.62 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0133841; expected ratio = 0.0001obtained abs = 2.27622e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00554582; expected ratio = 0.001obtained abs = 1.82549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.2411 - Final Residual ratio : 0.0253523 - Residual ratio : 0.000699544 - Slope : -2.01199 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.0151 - Final Residual ratio : 0.0145549 - Residual ratio : 0.000501632 - Slope : -1.52634 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.437 - Final Residual ratio : 0.013187 - Residual ratio : 0.000587734 - Slope : -1.1802 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.0033 - Final Residual ratio : 0.0119176 - Residual ratio : 0.000700899 - Slope : -0.894281 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4825 - Final Residual ratio : 0.0113503 - Residual ratio : 0.000841853 - Slope : -0.841947 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.8406 - Final Residual ratio : 0.00384732 - Residual ratio : 0.000354897 - Slope : -0.602045 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.0091 - Final Residual ratio : 0.00604014 - Residual ratio : 0.000670448 - Slope : -0.50017 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.48871 - Final Residual ratio : 0.00563431 - Residual ratio : 0.000752373 - Slope : -0.415727 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.24565 - Final Residual ratio : 0.00418192 - Residual ratio : 0.000669573 - Slope : -0.346748 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.59049 - Final Residual ratio : 0.00452098 - Residual ratio : 0.000808692 - Slope : -0.349123 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 337.79 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 485.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0188962; expected ratio = 0.0001obtained abs = 3.22981e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00977211; expected ratio = 0.001obtained abs = 3.22293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.82343 - Final Residual ratio : 0.00320672 - Residual ratio : 0.000664821 - Slope : -0.26779 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.54297 - Final Residual ratio : 0.00451245 - Residual ratio : 0.00099328 - Slope : -0.252137 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.3903 - Final Residual ratio : 0.00310229 - Residual ratio : 0.000706625 - Slope : -0.230905 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.7411 - Final Residual ratio : 0.00803763 - Residual ratio : 0.000584933 - Slope : -0.722794 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.26462 - Final Residual ratio : 0.00344803 - Residual ratio : 0.00080852 - Slope : -0.224272 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.78687 - Final Residual ratio : 0.00237612 - Residual ratio : 0.000627463 - Slope : -0.189225 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.23994 - Final Residual ratio : 0.00320711 - Residual ratio : 0.000756405 - Slope : -0.222986 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.06582 - Final Residual ratio : 0.00170545 - Residual ratio : 0.000419459 - Slope : -0.213901 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.90939 - Final Residual ratio : 0.00241388 - Residual ratio : 0.000617458 - Slope : -0.20563 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.97965 - Final Residual ratio : 0.00338677 - Residual ratio : 0.000851024 - Slope : -0.209277 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 340.41 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 489.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00682264; expected ratio = 0.0001obtained abs = 1.16764e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00296531; expected ratio = 0.001obtained abs = 0.979006; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3361 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.75558 - Final Residual ratio : 0.00337043 - Residual ratio : 0.000897446 - Slope : -0.234513 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.7353 - Final Residual ratio : 0.00272163 - Residual ratio : 0.000728625 - Slope : -0.196451 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.73063 - Final Residual ratio : 0.00190481 - Residual ratio : 0.000510588 - Slope : -0.196249 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.72606 - Final Residual ratio : 0.00164748 - Residual ratio : 0.00044215 - Slope : -0.196022 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.85142 - Final Residual ratio : 0.00211493 - Residual ratio : 0.00054913 - Slope : -0.202595 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.69562 - Final Residual ratio : 0.00275159 - Residual ratio : 0.000744556 - Slope : -0.194361 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.68 - Final Residual ratio : 0.00339472 - Residual ratio : 0.000922476 - Slope : -0.193506 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.66481 - Final Residual ratio : 0.00307114 - Residual ratio : 0.000838008 - Slope : -0.228858 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.6481 - Final Residual ratio : 0.002979 - Residual ratio : 0.000816588 - Slope : -0.243008 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.74132 - Final Residual ratio : 0.00339884 - Residual ratio : 0.000908459 - Slope : -0.266995 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 339.19 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 434.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.019781; expected ratio = 0.0001obtained abs = 3.38403e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00225595; expected ratio = 0.001obtained abs = 0.745347; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.60843 - Final Residual ratio : 0.00306732 - Residual ratio : 0.000850044 - Slope : -0.21208 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.59058 - Final Residual ratio : 0.00218424 - Residual ratio : 0.000608326 - Slope : -0.188863 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5778 - Final Residual ratio : 0.0018651 - Residual ratio : 0.000521298 - Slope : -0.188207 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.56606 - Final Residual ratio : 0.00168004 - Residual ratio : 0.00047112 - Slope : -0.187599 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.64084 - Final Residual ratio : 0.0018017 - Residual ratio : 0.000494859 - Slope : -0.191528 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.54016 - Final Residual ratio : 0.00208893 - Residual ratio : 0.000590066 - Slope : -0.186214 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.52862 - Final Residual ratio : 0.00263447 - Residual ratio : 0.0007466 - Slope : -0.185578 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.52011 - Final Residual ratio : 0.00295287 - Residual ratio : 0.000838857 - Slope : -0.185114 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 115.583 - Final Residual ratio : 0.112776 - Residual ratio : 0.000975715 - Slope : -6.79234 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 77.0709 - Final Residual ratio : 0.0365047 - Residual ratio : 0.000473651 - Slope : -4.53143 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 339.80 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0174355; expected ratio = 0.0001obtained abs = 2.97897e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00154657; expected ratio = 0.001obtained abs = 0.510999; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.6727 - Final Residual ratio : 0.0229013 - Residual ratio : 0.000928206 - Slope : -1.36943 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 96.1125 - Final Residual ratio : 0.0792871 - Residual ratio : 0.000824941 - Slope : -5.05438 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.2184 - Final Residual ratio : 0.0219035 - Residual ratio : 0.000943365 - Slope : -1.2887 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.1984 - Final Residual ratio : 0.00954886 - Residual ratio : 0.00062828 - Slope : -0.799413 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.1868 - Final Residual ratio : 0.00503755 - Residual ratio : 0.000450312 - Slope : -0.532465 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.33687 - Final Residual ratio : 0.00423814 - Residual ratio : 0.000508362 - Slope : -0.396792 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.61824 - Final Residual ratio : 0.00363272 - Residual ratio : 0.000548895 - Slope : -0.314981 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.27463 - Final Residual ratio : 0.00312562 - Residual ratio : 0.000592576 - Slope : -0.251024 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.17353 - Final Residual ratio : 0.00274075 - Residual ratio : 0.000656699 - Slope : -0.189581 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.69567 - Final Residual ratio : 0.00261326 - Residual ratio : 0.000707113 - Slope : -0.17586 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 338.43 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 489.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0118597; expected ratio = 0.0001obtained abs = 2.02537e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000874843; expected ratio = 0.001obtained abs = 0.288924; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.82458 - Final Residual ratio : 0.00219235 - Residual ratio : 0.000573226 - Slope : -0.201178 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.16123 - Final Residual ratio : 0.00272296 - Residual ratio : 0.000654364 - Slope : -0.218869 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.35411 - Final Residual ratio : 0.00427103 - Residual ratio : 0.000980918 - Slope : -0.228939 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.797 - Final Residual ratio : 0.0247614 - Residual ratio : 0.000831001 - Slope : -1.56696 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.7027 - Final Residual ratio : 0.00966165 - Residual ratio : 0.00090273 - Slope : -0.509193 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.3934 - Final Residual ratio : 0.00981825 - Residual ratio : 0.000861749 - Slope : -0.632421 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.37793 - Final Residual ratio : 0.00613989 - Residual ratio : 0.000832198 - Slope : -0.387989 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.49793 - Final Residual ratio : 0.00508344 - Residual ratio : 0.00092461 - Slope : -0.323109 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48595 - Final Residual ratio : 0.00446036 - Residual ratio : 0.000994295 - Slope : -0.224075 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79676 - Final Residual ratio : 0.00319777 - Residual ratio : 0.000842237 - Slope : -0.189678 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 337.82 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00755485; expected ratio = 0.0001obtained abs = 1.2911e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0011927; expected ratio = 0.001obtained abs = 0.394115; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.60684 - Final Residual ratio : 0.0020829 - Residual ratio : 0.000577485 - Slope : -0.180238 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.62954 - Final Residual ratio : 0.00197843 - Residual ratio : 0.000545091 - Slope : -0.241837 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.81284 - Final Residual ratio : 0.00327239 - Residual ratio : 0.000858255 - Slope : -0.200503 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 136.774 - Final Residual ratio : 0.08811 - Residual ratio : 0.000644202 - Slope : -8.54286 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 63.5924 - Final Residual ratio : 0.0450752 - Residual ratio : 0.000708815 - Slope : -3.73808 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.4252 - Final Residual ratio : 0.0178845 - Residual ratio : 0.000763473 - Slope : -1.30041 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2403 - Final Residual ratio : 0.0103518 - Residual ratio : 0.000637412 - Slope : -0.854209 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.7618 - Final Residual ratio : 0.0124619 - Residual ratio : 0.000976497 - Slope : -0.708298 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0994 - Final Residual ratio : 0.00648517 - Residual ratio : 0.000642136 - Slope : -0.531204 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.66532 - Final Residual ratio : 0.00742732 - Residual ratio : 0.00096895 - Slope : -0.403047 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796760e+05 Mflops = 339.01 -Solve time = 0.00 -Solve flops = 1.654400e+04 Mflops = 472.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0509465; expected ratio = 0.0001obtained abs = 8.71088e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00192838; expected ratio = 0.001obtained abs = 0.636822; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.7217 - Final Residual ratio : 0.00380261 - Residual ratio : 0.000664594 - Slope : -0.285895 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.26222 - Final Residual ratio : 0.00299784 - Residual ratio : 0.00070335 - Slope : -0.212961 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.84549 - Final Residual ratio : 0.0022123 - Residual ratio : 0.000575297 - Slope : -0.192164 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.2074 - Final Residual ratio : 0.00266456 - Residual ratio : 0.000633304 - Slope : -0.210237 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.42665 - Final Residual ratio : 0.00377438 - Residual ratio : 0.000852651 - Slope : -0.232783 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.78905 - Final Residual ratio : 0.00332369 - Residual ratio : 0.000694018 - Slope : -0.239286 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.71282 - Final Residual ratio : 0.00352487 - Residual ratio : 0.000747933 - Slope : -0.247858 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48418 - Final Residual ratio : 0.00320939 - Residual ratio : 0.000715713 - Slope : -0.235841 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.20236 - Final Residual ratio : 0.00413911 - Residual ratio : 0.000984949 - Slope : -0.220959 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.74137 - Final Residual ratio : 0.00296967 - Residual ratio : 0.00079374 - Slope : -0.196758 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.3951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 337.82 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0249991; expected ratio = 0.0001obtained abs = 4.28631e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00269957; expected ratio = 0.001obtained abs = 0.892456; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.3961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.75718 - Final Residual ratio : 0.00352649 - Residual ratio : 0.000938601 - Slope : -0.208536 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.67091 - Final Residual ratio : 0.00255419 - Residual ratio : 0.000695792 - Slope : -0.193071 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.65128 - Final Residual ratio : 0.00351384 - Residual ratio : 0.000962359 - Slope : -0.191988 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.3991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.67925 - Final Residual ratio : 0.00341521 - Residual ratio : 0.000928235 - Slope : -0.193465 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.3991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.51371 - Final Residual ratio : 0.00251178 - Residual ratio : 0.000714852 - Slope : -0.1848 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 0.4011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 53.2673 - Final Residual ratio : 0.0403694 - Residual ratio : 0.000757864 - Slope : -2.80142 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.701 - Final Residual ratio : 0.0160829 - Residual ratio : 0.000708464 - Slope : -1.13425 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5424 - Final Residual ratio : 0.00695819 - Residual ratio : 0.000602838 - Slope : -0.678554 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.13709 - Final Residual ratio : 0.00529548 - Residual ratio : 0.000741966 - Slope : -0.339609 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.88029 - Final Residual ratio : 0.00380039 - Residual ratio : 0.000646294 - Slope : -0.267113 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 336.62 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0239348; expected ratio = 0.0001obtained abs = 4.09919e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00211737; expected ratio = 0.001obtained abs = 0.700279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.24259 - Final Residual ratio : 0.00338232 - Residual ratio : 0.000541813 - Slope : -0.2836 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.1426 - Final Residual ratio : 0.0150077 - Residual ratio : 0.000827206 - Slope : -0.954083 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.06257 - Final Residual ratio : 0.00537068 - Residual ratio : 0.000760442 - Slope : -0.35286 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.60299 - Final Residual ratio : 0.00529857 - Residual ratio : 0.000945668 - Slope : -0.279885 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.07172 - Final Residual ratio : 0.0038427 - Residual ratio : 0.000757673 - Slope : -0.29811 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.57155 - Final Residual ratio : 0.00404964 - Residual ratio : 0.000885835 - Slope : -0.25375 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.10281 - Final Residual ratio : 0.00330188 - Residual ratio : 0.000804786 - Slope : -0.22775 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.80935 - Final Residual ratio : 0.00305976 - Residual ratio : 0.000803222 - Slope : -0.211461 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.66171 - Final Residual ratio : 0.00274394 - Residual ratio : 0.000749362 - Slope : -0.182948 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.42176 - Final Residual ratio : 0.00248824 - Residual ratio : 0.000727181 - Slope : -0.170964 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 340.41 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 485.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0232818; expected ratio = 0.0001obtained abs = 3.99136e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00308683; expected ratio = 0.001obtained abs = 1.02236; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5656 - Final Residual ratio : 0.00169686 - Residual ratio : 0.000475897 - Slope : -0.178195 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4171 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.55975 - Final Residual ratio : 0.00152618 - Residual ratio : 0.000428732 - Slope : -0.177911 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5483 - Final Residual ratio : 0.00206844 - Residual ratio : 0.000582938 - Slope : -0.177312 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5315 - Final Residual ratio : 0.0021053 - Residual ratio : 0.000596149 - Slope : -0.17647 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4201 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.32124 - Final Residual ratio : 0.00194489 - Residual ratio : 0.000585591 - Slope : -0.165965 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.48135 - Final Residual ratio : 0.00312311 - Residual ratio : 0.000897096 - Slope : -0.183065 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47815 - Final Residual ratio : 0.00299225 - Residual ratio : 0.000860298 - Slope : -0.182903 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47606 - Final Residual ratio : 0.00301304 - Residual ratio : 0.000866797 - Slope : -0.182792 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47549 - Final Residual ratio : 0.00300527 - Residual ratio : 0.000864705 - Slope : -0.182762 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.27827 - Final Residual ratio : 0.00297804 - Residual ratio : 0.000908416 - Slope : -0.172384 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 333.50 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0168533; expected ratio = 0.0001obtained abs = 2.89231e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00249563; expected ratio = 0.001obtained abs = 0.827629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.46151 - Final Residual ratio : 0.00313769 - Residual ratio : 0.000906449 - Slope : -0.18202 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4271 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47127 - Final Residual ratio : 0.00335568 - Residual ratio : 0.000966702 - Slope : -0.182522 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47708 - Final Residual ratio : 0.00166512 - Residual ratio : 0.000478884 - Slope : -0.173771 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47939 - Final Residual ratio : 0.00183471 - Residual ratio : 0.000527309 - Slope : -0.173878 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.276 - Final Residual ratio : 0.00186896 - Residual ratio : 0.0005705 - Slope : -0.163707 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.46268 - Final Residual ratio : 0.00184824 - Residual ratio : 0.00053376 - Slope : -0.173042 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.46908 - Final Residual ratio : 0.00341413 - Residual ratio : 0.000984159 - Slope : -0.182403 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47188 - Final Residual ratio : 0.00326311 - Residual ratio : 0.000939869 - Slope : -0.182559 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47243 - Final Residual ratio : 0.0031366 - Residual ratio : 0.000903285 - Slope : -0.182595 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.26301 - Final Residual ratio : 0.0030091 - Residual ratio : 0.000922184 - Slope : -0.171579 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 337.82 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 475.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0117924; expected ratio = 0.0001obtained abs = 2.02665e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00300493; expected ratio = 0.001obtained abs = 0.997811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.45439 - Final Residual ratio : 0.00306078 - Residual ratio : 0.000886057 - Slope : -0.181649 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4371 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.46044 - Final Residual ratio : 0.00314401 - Residual ratio : 0.000908556 - Slope : -0.181963 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.46256 - Final Residual ratio : 0.0032854 - Residual ratio : 0.000948834 - Slope : -0.182067 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.4627 - Final Residual ratio : 0.00342669 - Residual ratio : 0.0009896 - Slope : -0.182067 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.24849 - Final Residual ratio : 0.00170978 - Residual ratio : 0.00052633 - Slope : -0.162339 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.44525 - Final Residual ratio : 0.00179774 - Residual ratio : 0.000521802 - Slope : -0.172173 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.45252 - Final Residual ratio : 0.00175934 - Residual ratio : 0.000509581 - Slope : -0.172538 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.45619 - Final Residual ratio : 0.00336703 - Residual ratio : 0.000974202 - Slope : -0.181728 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.45819 - Final Residual ratio : 0.00325643 - Residual ratio : 0.000941657 - Slope : -0.181839 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.7823 - Final Residual ratio : 0.029776 - Residual ratio : 0.000730121 - Slope : -2.39721 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 340.41 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00798925; expected ratio = 0.0001obtained abs = 1.37388e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00156544; expected ratio = 0.001obtained abs = 0.52017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.4842 - Final Residual ratio : 0.023484 - Residual ratio : 0.000886719 - Slope : -1.32304 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9717 - Final Residual ratio : 0.0092882 - Residual ratio : 0.000775844 - Slope : -0.629603 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.92301 - Final Residual ratio : 0.00627782 - Residual ratio : 0.000792353 - Slope : -0.494796 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.45396 - Final Residual ratio : 0.0059825 - Residual ratio : 0.00092695 - Slope : -0.358221 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.46613 - Final Residual ratio : 0.00319411 - Residual ratio : 0.000584346 - Slope : -0.287523 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.74599 - Final Residual ratio : 0.00343728 - Residual ratio : 0.000724249 - Slope : -0.249608 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.6324 - Final Residual ratio : 0.0261274 - Residual ratio : 0.000945535 - Slope : -1.84042 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.60142 - Final Residual ratio : 0.00814583 - Residual ratio : 0.000848399 - Slope : -0.479664 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.84471 - Final Residual ratio : 0.00382447 - Residual ratio : 0.000654348 - Slope : -0.292044 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.3204 - Final Residual ratio : 0.00492465 - Residual ratio : 0.000925618 - Slope : -0.265774 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 337.82 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00627805; expected ratio = 0.0001obtained abs = 1.08073e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00156923; expected ratio = 0.001obtained abs = 0.521815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.2423 - Final Residual ratio : 0.00266773 - Residual ratio : 0.000628841 - Slope : -0.223139 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.66966 - Final Residual ratio : 0.00295178 - Residual ratio : 0.000804374 - Slope : -0.203706 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.3032 - Final Residual ratio : 0.00226388 - Residual ratio : 0.000685358 - Slope : -0.173734 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.0849 - Final Residual ratio : 0.00299213 - Residual ratio : 0.000969927 - Slope : -0.171217 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.89721 - Final Residual ratio : 0.00282983 - Residual ratio : 0.000976745 - Slope : -0.192958 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.97511 - Final Residual ratio : 0.00234292 - Residual ratio : 0.000787505 - Slope : -0.156462 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.01209 - Final Residual ratio : 0.00234893 - Residual ratio : 0.000779833 - Slope : -0.150487 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.07048 - Final Residual ratio : 0.00257168 - Residual ratio : 0.000837551 - Slope : -0.153395 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12358 - Final Residual ratio : 0.00250129 - Residual ratio : 0.000800778 - Slope : -0.156054 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.07207 - Final Residual ratio : 0.00230308 - Residual ratio : 0.000749683 - Slope : -0.153488 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800940e+05 Mflops = 340.41 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0116724; expected ratio = 0.0001obtained abs = 2.01424e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00488816; expected ratio = 0.001obtained abs = 1.62877; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.17304 - Final Residual ratio : 0.00240567 - Residual ratio : 0.00075816 - Slope : -0.158532 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.17244 - Final Residual ratio : 0.00244981 - Residual ratio : 0.000772214 - Slope : -0.1585 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.16327 - Final Residual ratio : 0.00243298 - Residual ratio : 0.000769134 - Slope : -0.158042 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.14982 - Final Residual ratio : 0.00228259 - Residual ratio : 0.000724675 - Slope : -0.157377 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.05424 - Final Residual ratio : 0.00203315 - Residual ratio : 0.000665681 - Slope : -0.15261 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4711 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12587 - Final Residual ratio : 0.00217797 - Residual ratio : 0.000696756 - Slope : -0.156184 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12151 - Final Residual ratio : 0.00229513 - Residual ratio : 0.000735262 - Slope : -0.155961 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12214 - Final Residual ratio : 0.00236541 - Residual ratio : 0.000757625 - Slope : -0.155989 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12424 - Final Residual ratio : 0.00237464 - Residual ratio : 0.000760072 - Slope : -0.156093 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.04289 - Final Residual ratio : 0.0022289 - Residual ratio : 0.000732495 - Slope : -0.152033 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800480e+05 Mflops = 338.95 -Solve time = 0.00 -Solve flops = 1.656200e+04 Mflops = 489.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00994284; expected ratio = 0.0001obtained abs = 1.7191e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00210337; expected ratio = 0.001obtained abs = 0.701294; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12634 - Final Residual ratio : 0.002421 - Residual ratio : 0.000774389 - Slope : -0.156196 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12836 - Final Residual ratio : 0.0025113 - Residual ratio : 0.000802752 - Slope : -0.156292 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13117 - Final Residual ratio : 0.00258841 - Residual ratio : 0.000826658 - Slope : -0.156429 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13305 - Final Residual ratio : 0.00260434 - Residual ratio : 0.000831246 - Slope : -0.156522 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.05082 - Final Residual ratio : 0.00242679 - Residual ratio : 0.000795458 - Slope : -0.152419 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13291 - Final Residual ratio : 0.00249517 - Residual ratio : 0.000796438 - Slope : -0.156521 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13394 - Final Residual ratio : 0.00247859 - Residual ratio : 0.000790885 - Slope : -0.156573 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4831 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13563 - Final Residual ratio : 0.00249829 - Residual ratio : 0.000796742 - Slope : -0.156656 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13601 - Final Residual ratio : 0.00252997 - Residual ratio : 0.00080675 - Slope : -0.156674 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.05209 - Final Residual ratio : 0.00239947 - Residual ratio : 0.000786174 - Slope : -0.152485 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 339.98 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 486.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00687726; expected ratio = 0.0001obtained abs = 1.19112e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00175078; expected ratio = 0.001obtained abs = 0.584192; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13168 - Final Residual ratio : 0.00256772 - Residual ratio : 0.000819916 - Slope : -0.156456 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13049 - Final Residual ratio : 0.00260141 - Residual ratio : 0.00083099 - Slope : -0.156395 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13081 - Final Residual ratio : 0.00263643 - Residual ratio : 0.000842091 - Slope : -0.156409 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13085 - Final Residual ratio : 0.00265526 - Residual ratio : 0.000848094 - Slope : -0.15641 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.04853 - Final Residual ratio : 0.00249163 - Residual ratio : 0.000817323 - Slope : -0.152302 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12857 - Final Residual ratio : 0.00260615 - Residual ratio : 0.000833016 - Slope : -0.156298 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12866 - Final Residual ratio : 0.00258425 - Residual ratio : 0.000825993 - Slope : -0.156304 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13013 - Final Residual ratio : 0.00258107 - Residual ratio : 0.000824591 - Slope : -0.156377 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13073 - Final Residual ratio : 0.00259628 - Residual ratio : 0.000829288 - Slope : -0.156407 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.0494 - Final Residual ratio : 0.00245458 - Residual ratio : 0.000804938 - Slope : -0.152347 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.4951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 340.59 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00995448; expected ratio = 0.0001obtained abs = 1.72724e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0017723; expected ratio = 0.001obtained abs = 0.591855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.4961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12762 - Final Residual ratio : 0.00262953 - Residual ratio : 0.000840746 - Slope : -0.156249 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12649 - Final Residual ratio : 0.00265395 - Residual ratio : 0.00084886 - Slope : -0.156192 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12697 - Final Residual ratio : 0.00267633 - Residual ratio : 0.000855888 - Slope : -0.156215 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.4991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12701 - Final Residual ratio : 0.00269048 - Residual ratio : 0.0008604 - Slope : -0.156216 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.4991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.3771 - Final Residual ratio : 0.00755871 - Residual ratio : 0.00066438 - Slope : -0.668796 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 0.5011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 56.2206 - Final Residual ratio : 0.046783 - Residual ratio : 0.000832134 - Slope : -2.95651 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.2572 - Final Residual ratio : 0.0141815 - Residual ratio : 0.000994686 - Slope : -0.678241 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.5543 - Final Residual ratio : 0.011526 - Residual ratio : 0.000791928 - Slope : -0.72714 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.52065 - Final Residual ratio : 0.00532212 - Residual ratio : 0.000707668 - Slope : -0.341606 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.64961 - Final Residual ratio : 0.00404371 - Residual ratio : 0.000715751 - Slope : -0.245459 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 339.37 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 489.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00715756; expected ratio = 0.0001obtained abs = 1.24309e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00148515; expected ratio = 0.001obtained abs = 0.496134; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.82573 - Final Residual ratio : 0.0043662 - Residual ratio : 0.000904774 - Slope : -0.219153 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.08956 - Final Residual ratio : 0.00286054 - Residual ratio : 0.000699473 - Slope : -0.177683 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.45136 - Final Residual ratio : 0.00260508 - Residual ratio : 0.000754798 - Slope : -0.149946 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.07065 - Final Residual ratio : 0.00287624 - Residual ratio : 0.000936688 - Slope : -0.146085 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5101 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.97019 - Final Residual ratio : 0.00283898 - Residual ratio : 0.000955827 - Slope : -0.148367 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.09068 - Final Residual ratio : 0.00289137 - Residual ratio : 0.000935512 - Slope : -0.15439 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.19176 - Final Residual ratio : 0.00307226 - Residual ratio : 0.00096256 - Slope : -0.159434 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.22868 - Final Residual ratio : 0.00249466 - Residual ratio : 0.000772656 - Slope : -0.169799 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.20124 - Final Residual ratio : 0.00268198 - Residual ratio : 0.000837796 - Slope : -0.159928 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12037 - Final Residual ratio : 0.00259618 - Residual ratio : 0.000832011 - Slope : -0.155889 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 337.55 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0111773; expected ratio = 0.0001obtained abs = 1.94941e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00360542; expected ratio = 0.001obtained abs = 1.20622; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.07111 - Final Residual ratio : 0.00277804 - Residual ratio : 0.000904574 - Slope : -0.153416 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.01289 - Final Residual ratio : 0.00205341 - Residual ratio : 0.000681543 - Slope : -0.143373 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.96997 - Final Residual ratio : 0.00270269 - Residual ratio : 0.000910004 - Slope : -0.148363 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.94255 - Final Residual ratio : 0.00228797 - Residual ratio : 0.000777545 - Slope : -0.140013 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.91302 - Final Residual ratio : 0.002832 - Residual ratio : 0.000972186 - Slope : -0.14551 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.92271 - Final Residual ratio : 0.00218436 - Residual ratio : 0.000747374 - Slope : -0.146026 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.92299 - Final Residual ratio : 0.0027875 - Residual ratio : 0.000953647 - Slope : -0.153695 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 130.532 - Final Residual ratio : 0.0746128 - Residual ratio : 0.000571607 - Slope : -6.86616 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.2475 - Final Residual ratio : 0.0657308 - Residual ratio : 0.00092257 - Slope : -3.95454 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.6839 - Final Residual ratio : 0.0330684 - Residual ratio : 0.000926703 - Slope : -1.78254 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 338.01 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0121678; expected ratio = 0.0001obtained abs = 2.11214e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00483572; expected ratio = 0.001obtained abs = 1.61619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.9259 - Final Residual ratio : 0.0158871 - Residual ratio : 0.000759206 - Slope : -0.950456 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5271 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.0911 - Final Residual ratio : 0.0175465 - Residual ratio : 0.0009699 - Slope : -0.860644 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.946 - Final Residual ratio : 0.0102668 - Residual ratio : 0.000686931 - Slope : -0.711223 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9067 - Final Residual ratio : 0.00902592 - Residual ratio : 0.000758051 - Slope : -0.594886 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5301 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 101.815 - Final Residual ratio : 0.0879891 - Residual ratio : 0.000864208 - Slope : -5.65148 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 70.024 - Final Residual ratio : 0.0536996 - Residual ratio : 0.000766875 - Slope : -3.88724 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.7138 - Final Residual ratio : 0.0130821 - Residual ratio : 0.000575953 - Slope : -1.19477 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.0677 - Final Residual ratio : 0.00581565 - Residual ratio : 0.00052546 - Slope : -0.61455 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.78373 - Final Residual ratio : 0.0044263 - Residual ratio : 0.000503921 - Slope : -0.487739 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.34617 - Final Residual ratio : 0.00422712 - Residual ratio : 0.000575418 - Slope : -0.367097 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 339.37 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 486.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00586789; expected ratio = 0.0001obtained abs = 1.01919e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00288405; expected ratio = 0.001obtained abs = 0.964078; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.18419 - Final Residual ratio : 0.0058792 - Residual ratio : 0.000950683 - Slope : -0.325174 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.15653 - Final Residual ratio : 0.00404128 - Residual ratio : 0.000783721 - Slope : -0.257625 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.16043 - Final Residual ratio : 0.00286485 - Residual ratio : 0.000688595 - Slope : -0.197979 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36697 - Final Residual ratio : 0.00275376 - Residual ratio : 0.000817877 - Slope : -0.160201 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.01023 - Final Residual ratio : 0.00261323 - Residual ratio : 0.000868118 - Slope : -0.176919 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.01262 - Final Residual ratio : 0.0018795 - Residual ratio : 0.000623874 - Slope : -0.15846 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12611 - Final Residual ratio : 0.00272974 - Residual ratio : 0.000873206 - Slope : -0.164389 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5431 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.15736 - Final Residual ratio : 0.00188955 - Residual ratio : 0.000598459 - Slope : -0.15026 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.07944 - Final Residual ratio : 0.00265991 - Residual ratio : 0.000863763 - Slope : -0.161936 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.2007 - Final Residual ratio : 0.0483878 - Residual ratio : 0.000679597 - Slope : -4.18543 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 339.98 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 489.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00570242; expected ratio = 0.0001obtained abs = 9.92884e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00129409; expected ratio = 0.001obtained abs = 0.432978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.9001 - Final Residual ratio : 0.0348451 - Residual ratio : 0.000520852 - Slope : -4.17908 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.6442 - Final Residual ratio : 0.0208516 - Residual ratio : 0.000920839 - Slope : -1.1907 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.1056 - Final Residual ratio : 0.0140626 - Residual ratio : 0.000822108 - Slope : -0.854575 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.0677 - Final Residual ratio : 0.0144794 - Residual ratio : 0.000901148 - Slope : -0.802661 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.3107 - Final Residual ratio : 0.0107726 - Residual ratio : 0.00080932 - Slope : -0.664995 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1438 - Final Residual ratio : 0.00906117 - Residual ratio : 0.000893267 - Slope : -0.53341 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.6092 - Final Residual ratio : 0.00631559 - Residual ratio : 0.000829993 - Slope : -0.400152 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.91164 - Final Residual ratio : 0.00548388 - Residual ratio : 0.000927641 - Slope : -0.32812 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.86581 - Final Residual ratio : 0.00439205 - Residual ratio : 0.000902635 - Slope : -0.285966 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.26728 - Final Residual ratio : 0.00338051 - Residual ratio : 0.000792192 - Slope : -0.236884 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 340.59 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 489.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0124924; expected ratio = 0.0001obtained abs = 2.18906e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00517892; expected ratio = 0.001obtained abs = 1.73652; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.71653 - Final Residual ratio : 0.00337666 - Residual ratio : 0.000908552 - Slope : -0.195429 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.35916 - Final Residual ratio : 0.0018046 - Residual ratio : 0.000537219 - Slope : -0.167868 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.07998 - Final Residual ratio : 0.00236822 - Residual ratio : 0.000768908 - Slope : -0.153881 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.5774 - Final Residual ratio : 0.0183775 - Residual ratio : 0.000666396 - Slope : -1.45048 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.7003 - Final Residual ratio : 0.00737066 - Residual ratio : 0.000629957 - Slope : -0.615415 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.89253 - Final Residual ratio : 0.00469444 - Residual ratio : 0.000681091 - Slope : -0.362518 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.90682 - Final Residual ratio : 0.00490018 - Residual ratio : 0.00082958 - Slope : -0.295096 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.11825 - Final Residual ratio : 0.00385835 - Residual ratio : 0.000753841 - Slope : -0.243543 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.57909 - Final Residual ratio : 0.00386307 - Residual ratio : 0.000843631 - Slope : -0.207965 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.38145 - Final Residual ratio : 0.003318 - Residual ratio : 0.000757284 - Slope : -0.208482 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453234 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 338.01 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 476.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00443617; expected ratio = 0.0001obtained abs = 7.77925e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00174908; expected ratio = 0.001obtained abs = 0.58683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.99209 - Final Residual ratio : 0.00355127 - Residual ratio : 0.000889576 - Slope : -0.199427 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.6001 - Final Residual ratio : 0.00306415 - Residual ratio : 0.000851129 - Slope : -0.179852 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.19511 - Final Residual ratio : 0.00244768 - Residual ratio : 0.000766071 - Slope : -0.159633 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.86723 - Final Residual ratio : 0.00200081 - Residual ratio : 0.000697819 - Slope : -0.143262 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.73652 - Final Residual ratio : 0.00213244 - Residual ratio : 0.000779251 - Slope : -0.13672 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.54041 - Final Residual ratio : 0.00148912 - Residual ratio : 0.000586173 - Slope : -0.120901 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.48497 - Final Residual ratio : 0.00158228 - Residual ratio : 0.000636741 - Slope : -0.118256 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.43731 - Final Residual ratio : 0.00149223 - Residual ratio : 0.000612243 - Slope : -0.115991 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.37749 - Final Residual ratio : 0.00151484 - Residual ratio : 0.000637159 - Slope : -0.113142 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.37336 - Final Residual ratio : 0.00134061 - Residual ratio : 0.000564857 - Slope : -0.112953 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 339.98 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00775396; expected ratio = 0.0001obtained abs = 1.36353e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00269035; expected ratio = 0.001obtained abs = 0.903476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5761 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.22541 - Final Residual ratio : 0.0012744 - Residual ratio : 0.00057266 - Slope : -0.105911 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.17134 - Final Residual ratio : 0.00134818 - Residual ratio : 0.000620899 - Slope : -0.103333 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.13591 - Final Residual ratio : 0.00137012 - Residual ratio : 0.000641467 - Slope : -0.101645 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11657 - Final Residual ratio : 0.00140703 - Residual ratio : 0.000664768 - Slope : -0.100722 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.14954 - Final Residual ratio : 0.00146055 - Residual ratio : 0.000679471 - Slope : -0.10229 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.09519 - Final Residual ratio : 0.0015972 - Residual ratio : 0.000762317 - Slope : -0.0996949 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.102 - Final Residual ratio : 0.00159667 - Residual ratio : 0.000759598 - Slope : -0.100019 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.10839 - Final Residual ratio : 0.00156485 - Residual ratio : 0.000742198 - Slope : -0.100325 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11032 - Final Residual ratio : 0.00152356 - Residual ratio : 0.000721957 - Slope : -0.100419 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11967 - Final Residual ratio : 0.00136512 - Residual ratio : 0.000644022 - Slope : -0.100872 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 336.20 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 486.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00871555; expected ratio = 0.0001obtained abs = 1.53738e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00209042; expected ratio = 0.001obtained abs = 0.702696; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08716 - Final Residual ratio : 0.00141019 - Residual ratio : 0.000675651 - Slope : -0.0993213 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08437 - Final Residual ratio : 0.00137862 - Residual ratio : 0.000661412 - Slope : -0.0991898 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08198 - Final Residual ratio : 0.00137253 - Residual ratio : 0.000659244 - Slope : -0.0990764 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.07899 - Final Residual ratio : 0.00139815 - Residual ratio : 0.000672515 - Slope : -0.0989331 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0692 - Final Residual ratio : 0.00132138 - Residual ratio : 0.000638597 - Slope : -0.0984702 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05788 - Final Residual ratio : 0.00146175 - Residual ratio : 0.000710316 - Slope : -0.0979247 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05883 - Final Residual ratio : 0.00148815 - Residual ratio : 0.000722814 - Slope : -0.0979685 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05958 - Final Residual ratio : 0.00149623 - Residual ratio : 0.000726476 - Slope : -0.0980039 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05874 - Final Residual ratio : 0.00149318 - Residual ratio : 0.000725288 - Slope : -0.0979641 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03084 - Final Residual ratio : 0.00136814 - Residual ratio : 0.000673681 - Slope : -0.0966415 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.5951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 340.59 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0130223; expected ratio = 0.0001obtained abs = 2.30624e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00281029; expected ratio = 0.001obtained abs = 0.945441; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.5961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03966 - Final Residual ratio : 0.00145783 - Residual ratio : 0.000714741 - Slope : -0.0970572 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.04081 - Final Residual ratio : 0.00144945 - Residual ratio : 0.000710233 - Slope : -0.0971123 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.04186 - Final Residual ratio : 0.00144443 - Residual ratio : 0.00070741 - Slope : -0.0971627 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.5991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.04201 - Final Residual ratio : 0.00144761 - Residual ratio : 0.000708913 - Slope : -0.0971695 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.5991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00444 - Final Residual ratio : 0.00133584 - Residual ratio : 0.000666441 - Slope : -0.0953859 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 0.6011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0266 - Final Residual ratio : 0.00146035 - Residual ratio : 0.000720591 - Slope : -0.096435 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02879 - Final Residual ratio : 0.0014752 - Residual ratio : 0.000727133 - Slope : -0.0965389 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02998 - Final Residual ratio : 0.00148205 - Residual ratio : 0.000730079 - Slope : -0.0965953 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02977 - Final Residual ratio : 0.00148266 - Residual ratio : 0.000730454 - Slope : -0.0965852 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.97513 - Final Residual ratio : 0.0013569 - Residual ratio : 0.000686995 - Slope : -0.0939893 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 336.20 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 489.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0296083; expected ratio = 0.0001obtained abs = 5.27905e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00553843; expected ratio = 0.001obtained abs = 1.86401; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.5603 - Final Residual ratio : 0.0189059 - Residual ratio : 0.00071181 - Slope : -1.47452 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.22923 - Final Residual ratio : 0.00557293 - Residual ratio : 0.000770888 - Slope : -0.424921 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03287 - Final Residual ratio : 0.00192022 - Residual ratio : 0.000944588 - Slope : -0.11283 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.90865 - Final Residual ratio : 0.00141455 - Residual ratio : 0.000741126 - Slope : -0.0953617 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.96959 - Final Residual ratio : 0.0017031 - Residual ratio : 0.000864697 - Slope : -0.0983946 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11358 - Final Residual ratio : 0.00180148 - Residual ratio : 0.000852338 - Slope : -0.105589 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11589 - Final Residual ratio : 0.0020741 - Residual ratio : 0.000980249 - Slope : -0.105691 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.06499 - Final Residual ratio : 0.00148596 - Residual ratio : 0.000719598 - Slope : -0.098262 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00873 - Final Residual ratio : 0.00136908 - Residual ratio : 0.000681563 - Slope : -0.0955887 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.92629 - Final Residual ratio : 0.00187095 - Residual ratio : 0.000971273 - Slope : -0.0962208 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 338.16 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00865867; expected ratio = 0.0001obtained abs = 1.5484e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0025039; expected ratio = 0.001obtained abs = 0.844011; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.95718 - Final Residual ratio : 0.00169196 - Residual ratio : 0.000864492 - Slope : -0.0977743 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.96694 - Final Residual ratio : 0.00143739 - Residual ratio : 0.000730773 - Slope : -0.0982752 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98468 - Final Residual ratio : 0.00157396 - Residual ratio : 0.000793055 - Slope : -0.0991553 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6191 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.297 - Final Residual ratio : 0.0416384 - Residual ratio : 0.000618725 - Slope : -3.9562 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.4991 - Final Residual ratio : 0.0605882 - Residual ratio : 0.000871784 - Slope : -6.31259 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4712 - Final Residual ratio : 0.00765665 - Residual ratio : 0.000731213 - Slope : -0.615501 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.41005 - Final Residual ratio : 0.0053056 - Residual ratio : 0.000980693 - Slope : -0.28446 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.2671 - Final Residual ratio : 0.00449562 - Residual ratio : 0.000618626 - Slope : -0.382242 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.06872 - Final Residual ratio : 0.00703422 - Residual ratio : 0.000995119 - Slope : -0.504406 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.95084 - Final Residual ratio : 0.003406 - Residual ratio : 0.000572357 - Slope : -0.313023 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 338.61 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 476.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00813007; expected ratio = 0.0001obtained abs = 1.44966e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00282848; expected ratio = 0.001obtained abs = 0.952855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.08404 - Final Residual ratio : 0.00452331 - Residual ratio : 0.000889708 - Slope : -0.282196 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.30721 - Final Residual ratio : 0.00427063 - Residual ratio : 0.000991508 - Slope : -0.22647 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.74819 - Final Residual ratio : 0.00321395 - Residual ratio : 0.000857466 - Slope : -0.187249 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.39329 - Final Residual ratio : 0.00335324 - Residual ratio : 0.000988196 - Slope : -0.178418 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.98739 - Final Residual ratio : 0.00253654 - Residual ratio : 0.00084908 - Slope : -0.149243 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11331 - Final Residual ratio : 0.0029946 - Residual ratio : 0.00096187 - Slope : -0.163701 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.09535 - Final Residual ratio : 0.00290361 - Residual ratio : 0.000938055 - Slope : -0.171803 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.04763 - Final Residual ratio : 0.00303064 - Residual ratio : 0.000994425 - Slope : -0.160242 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.96246 - Final Residual ratio : 0.00219633 - Residual ratio : 0.000741388 - Slope : -0.148013 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 112.189 - Final Residual ratio : 0.048483 - Residual ratio : 0.000432156 - Slope : -5.90211 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 339.37 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 486.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0194081; expected ratio = 0.0001obtained abs = 3.44792e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00307065; expected ratio = 0.001obtained abs = 1.03413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.459 - Final Residual ratio : 0.0235348 - Residual ratio : 0.000703393 - Slope : -1.75976 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.109 - Final Residual ratio : 0.0179929 - Residual ratio : 0.000941597 - Slope : -1.123 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.66119 - Final Residual ratio : 0.00784969 - Residual ratio : 0.000812497 - Slope : -0.482667 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.36765 - Final Residual ratio : 0.00585095 - Residual ratio : 0.00079414 - Slope : -0.334627 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.21597 - Final Residual ratio : 0.00546255 - Residual ratio : 0.000878794 - Slope : -0.282296 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.32195 - Final Residual ratio : 0.00462688 - Residual ratio : 0.000869396 - Slope : -0.241696 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.40564 - Final Residual ratio : 0.00396319 - Residual ratio : 0.000899572 - Slope : -0.200076 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.69497 - Final Residual ratio : 0.00303189 - Residual ratio : 0.000820546 - Slope : -0.167815 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6441 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.3291 - Final Residual ratio : 0.00148696 - Residual ratio : 0.000446655 - Slope : -0.166381 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13891 - Final Residual ratio : 0.00313853 - Residual ratio : 0.000999879 - Slope : -0.156789 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 339.98 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 486.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0223753; expected ratio = 0.0001obtained abs = 4.00763e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00426525; expected ratio = 0.001obtained abs = 1.438; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.23143 - Final Residual ratio : 0.0029773 - Residual ratio : 0.000921356 - Slope : -0.134519 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.16401 - Final Residual ratio : 0.0016402 - Residual ratio : 0.000518392 - Slope : -0.121629 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.02947 - Final Residual ratio : 0.00210521 - Residual ratio : 0.000694911 - Slope : -0.159335 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84338 - Final Residual ratio : 0.00273136 - Residual ratio : 0.000960604 - Slope : -0.142032 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.52448 - Final Residual ratio : 0.00125316 - Residual ratio : 0.000496402 - Slope : -0.120153 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.49661 - Final Residual ratio : 0.0015127 - Residual ratio : 0.000605903 - Slope : -0.118814 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.38871 - Final Residual ratio : 0.00181091 - Residual ratio : 0.000758114 - Slope : -0.113662 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.3192 - Final Residual ratio : 0.00207456 - Residual ratio : 0.000894512 - Slope : -0.11034 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6541 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.28381 - Final Residual ratio : 0.00182256 - Residual ratio : 0.000798035 - Slope : -0.108666 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.14341 - Final Residual ratio : 0.00131487 - Residual ratio : 0.000613451 - Slope : -0.102004 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 330.03 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 486.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00690243; expected ratio = 0.0001obtained abs = 1.24074e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00251138; expected ratio = 0.001obtained abs = 0.84801; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.2696 - Final Residual ratio : 0.00163466 - Residual ratio : 0.000720241 - Slope : -0.113398 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.28053 - Final Residual ratio : 0.00159359 - Residual ratio : 0.000698781 - Slope : -0.113947 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.28464 - Final Residual ratio : 0.00190807 - Residual ratio : 0.000835175 - Slope : -0.114137 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.28058 - Final Residual ratio : 0.00141689 - Residual ratio : 0.000621283 - Slope : -0.108532 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.1364 - Final Residual ratio : 0.0012322 - Residual ratio : 0.000576765 - Slope : -0.101675 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6611 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.24609 - Final Residual ratio : 0.00144487 - Residual ratio : 0.000643283 - Slope : -0.106888 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.23379 - Final Residual ratio : 0.001504 - Residual ratio : 0.000673295 - Slope : -0.106299 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.5037 - Final Residual ratio : 0.0214414 - Residual ratio : 0.000556865 - Slope : -2.1379 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6641 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.0011 - Final Residual ratio : 0.00680872 - Residual ratio : 0.000400487 - Slope : -0.894437 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.46037 - Final Residual ratio : 0.00369744 - Residual ratio : 0.00067714 - Slope : -0.287193 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 336.80 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00467293; expected ratio = 0.0001obtained abs = 8.39578e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00148183; expected ratio = 0.001obtained abs = 0.50049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.21336 - Final Residual ratio : 0.00393219 - Residual ratio : 0.000933266 - Slope : -0.247614 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.3612 - Final Residual ratio : 0.0196596 - Residual ratio : 0.000607505 - Slope : -1.61707 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.31678 - Final Residual ratio : 0.0050656 - Residual ratio : 0.000692326 - Slope : -0.365586 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6691 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.00996 - Final Residual ratio : 0.00343846 - Residual ratio : 0.000686325 - Slope : -0.250326 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.42004 - Final Residual ratio : 0.00428474 - Residual ratio : 0.000969389 - Slope : -0.220788 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.02796 - Final Residual ratio : 0.00293848 - Residual ratio : 0.00097045 - Slope : -0.151251 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.39176 - Final Residual ratio : 0.00182878 - Residual ratio : 0.000764616 - Slope : -0.113806 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05865 - Final Residual ratio : 0.00183701 - Residual ratio : 0.000892335 - Slope : -0.0979436 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98002 - Final Residual ratio : 0.00179258 - Residual ratio : 0.000905335 - Slope : -0.0942012 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98405 - Final Residual ratio : 0.00185529 - Residual ratio : 0.000935104 - Slope : -0.0991096 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 339.98 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 486.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00910989; expected ratio = 0.0001obtained abs = 1.64509e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00340753; expected ratio = 0.001obtained abs = 1.15304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.17673 - Final Residual ratio : 0.00188512 - Residual ratio : 0.000866034 - Slope : -0.108742 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.228 - Final Residual ratio : 0.0530796 - Residual ratio : 0.000978823 - Slope : -2.85131 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.7549 - Final Residual ratio : 0.00890517 - Residual ratio : 0.000757568 - Slope : -0.587301 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6791 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.91547 - Final Residual ratio : 0.00593735 - Residual ratio : 0.000750095 - Slope : -0.439418 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.58702 - Final Residual ratio : 0.00416945 - Residual ratio : 0.000746274 - Slope : -0.26585 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.5818 - Final Residual ratio : 0.00445329 - Residual ratio : 0.000971953 - Slope : -0.217969 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79929 - Final Residual ratio : 0.00292765 - Residual ratio : 0.000770579 - Slope : -0.180779 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.07236 - Final Residual ratio : 0.00295122 - Residual ratio : 0.000960569 - Slope : -0.146162 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.44341 - Final Residual ratio : 0.00190711 - Residual ratio : 0.000780512 - Slope : -0.110977 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0031 - Final Residual ratio : 0.0016698 - Residual ratio : 0.000833611 - Slope : -0.0909739 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 336.80 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00443584; expected ratio = 0.0001obtained abs = 8.02838e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00191216; expected ratio = 0.001obtained abs = 0.647408; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.99528 - Final Residual ratio : 0.00150756 - Residual ratio : 0.000755565 - Slope : -0.0949416 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11525 - Final Residual ratio : 0.0017517 - Residual ratio : 0.000828125 - Slope : -0.111237 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.24439 - Final Residual ratio : 0.00133286 - Residual ratio : 0.000593865 - Slope : -0.106812 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.29655 - Final Residual ratio : 0.00225046 - Residual ratio : 0.000979931 - Slope : -0.114715 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.19662 - Final Residual ratio : 0.00136172 - Residual ratio : 0.000619916 - Slope : -0.104536 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.1805 - Final Residual ratio : 0.00127767 - Residual ratio : 0.00058595 - Slope : -0.0990557 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0804 - Final Residual ratio : 0.00116215 - Residual ratio : 0.00055862 - Slope : -0.0945106 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98885 - Final Residual ratio : 0.00120308 - Residual ratio : 0.000604912 - Slope : -0.0903475 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.91916 - Final Residual ratio : 0.00166475 - Residual ratio : 0.000867438 - Slope : -0.0913093 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80626 - Final Residual ratio : 0.00118127 - Residual ratio : 0.000653986 - Slope : -0.0820492 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.6951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 338.76 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00728683; expected ratio = 0.0001obtained abs = 1.32374e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.002718; expected ratio = 0.001obtained abs = 0.921473; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.6961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.85229 - Final Residual ratio : 0.0016787 - Residual ratio : 0.000906285 - Slope : -0.0881242 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8495 - Final Residual ratio : 0.00163049 - Residual ratio : 0.000881585 - Slope : -0.0879936 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.85611 - Final Residual ratio : 0.00162933 - Residual ratio : 0.000877818 - Slope : -0.0883085 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.6991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.865 - Final Residual ratio : 0.00164928 - Residual ratio : 0.000884329 - Slope : -0.0887311 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.6991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80174 - Final Residual ratio : 0.00154621 - Residual ratio : 0.00085818 - Slope : -0.0857234 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 0.7011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.87139 - Final Residual ratio : 0.00155607 - Residual ratio : 0.000831508 - Slope : -0.0890397 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.87041 - Final Residual ratio : 0.00158057 - Residual ratio : 0.000845039 - Slope : -0.0889919 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8658 - Final Residual ratio : 0.00138728 - Residual ratio : 0.000743528 - Slope : -0.0887818 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7041 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.85869 - Final Residual ratio : 0.00140086 - Residual ratio : 0.000753682 - Slope : -0.0884424 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.78181 - Final Residual ratio : 0.00150943 - Residual ratio : 0.000847135 - Slope : -0.0847762 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 330.03 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 472.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00833204; expected ratio = 0.0001obtained abs = 1.52099e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00287474; expected ratio = 0.001obtained abs = 0.976168; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84141 - Final Residual ratio : 0.00174182 - Residual ratio : 0.000945915 - Slope : -0.0876034 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83804 - Final Residual ratio : 0.00179058 - Residual ratio : 0.000974178 - Slope : -0.0874405 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83663 - Final Residual ratio : 0.0017858 - Residual ratio : 0.000972326 - Slope : -0.0873736 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83623 - Final Residual ratio : 0.00177297 - Residual ratio : 0.000965545 - Slope : -0.0873553 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77499 - Final Residual ratio : 0.00172258 - Residual ratio : 0.000970474 - Slope : -0.0844412 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83311 - Final Residual ratio : 0.00177698 - Residual ratio : 0.000969382 - Slope : -0.0872063 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83325 - Final Residual ratio : 0.00176849 - Residual ratio : 0.000964677 - Slope : -0.0872134 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7131 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83259 - Final Residual ratio : 0.0017307 - Residual ratio : 0.000944399 - Slope : -0.0871837 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83096 - Final Residual ratio : 0.00168318 - Residual ratio : 0.000919287 - Slope : -0.0871084 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77478 - Final Residual ratio : 0.00162087 - Residual ratio : 0.000913281 - Slope : -0.084436 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 340.59 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 489.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00870456; expected ratio = 0.0001obtained abs = 1.59643e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0032263; expected ratio = 0.001obtained abs = 1.09727; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82436 - Final Residual ratio : 0.00169348 - Residual ratio : 0.000928264 - Slope : -0.0867934 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82375 - Final Residual ratio : 0.00174657 - Residual ratio : 0.000957682 - Slope : -0.086762 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82375 - Final Residual ratio : 0.00179192 - Residual ratio : 0.000982548 - Slope : -0.0867597 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82391 - Final Residual ratio : 0.00180996 - Residual ratio : 0.000992352 - Slope : -0.0867664 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77304 - Final Residual ratio : 0.00176725 - Residual ratio : 0.000996736 - Slope : -0.0843462 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82151 - Final Residual ratio : 0.00179302 - Residual ratio : 0.00098436 - Slope : -0.086653 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82183 - Final Residual ratio : 0.0017638 - Residual ratio : 0.000968147 - Slope : -0.0866698 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82167 - Final Residual ratio : 0.00171231 - Residual ratio : 0.000939969 - Slope : -0.0866647 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82086 - Final Residual ratio : 0.0016503 - Residual ratio : 0.000906332 - Slope : -0.086629 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77015 - Final Residual ratio : 0.00158263 - Residual ratio : 0.000894061 - Slope : -0.0842177 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801920e+05 Mflops = 339.37 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 489.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00956074; expected ratio = 0.0001obtained abs = 1.7621e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0036724; expected ratio = 0.001obtained abs = 1.25104; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81605 - Final Residual ratio : 0.00164566 - Residual ratio : 0.000906175 - Slope : -0.0864 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81583 - Final Residual ratio : 0.00170676 - Residual ratio : 0.000939932 - Slope : -0.0863868 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81587 - Final Residual ratio : 0.0017639 - Residual ratio : 0.000971383 - Slope : -0.0863858 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81593 - Final Residual ratio : 0.00179421 - Residual ratio : 0.00098804 - Slope : -0.0863875 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.221 - Final Residual ratio : 0.0123771 - Residual ratio : 0.000870339 - Slope : -0.747823 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.68958 - Final Residual ratio : 0.00212812 - Residual ratio : 0.000791246 - Slope : -0.141445 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52925 - Final Residual ratio : 0.00131208 - Residual ratio : 0.000857988 - Slope : -0.076397 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8567 - Final Residual ratio : 0.0014022 - Residual ratio : 0.000755212 - Slope : -0.0883475 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.89846 - Final Residual ratio : 0.00153236 - Residual ratio : 0.000807161 - Slope : -0.09033 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82901 - Final Residual ratio : 0.00159327 - Residual ratio : 0.00087111 - Slope : -0.0870198 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806100e+05 Mflops = 337.58 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 490.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0199535; expected ratio = 0.0001obtained abs = 3.69787e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00487094; expected ratio = 0.001obtained abs = 1.6625; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82519 - Final Residual ratio : 0.00173129 - Residual ratio : 0.000948549 - Slope : -0.0868316 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.78664 - Final Residual ratio : 0.00174619 - Residual ratio : 0.000977358 - Slope : -0.084995 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76236 - Final Residual ratio : 0.00174967 - Residual ratio : 0.000992801 - Slope : -0.0838384 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7519 - Final Residual ratio : 0.00103868 - Residual ratio : 0.000592886 - Slope : -0.0795847 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.71202 - Final Residual ratio : 0.00100715 - Residual ratio : 0.000588282 - Slope : -0.0777731 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75451 - Final Residual ratio : 0.00174322 - Residual ratio : 0.000993569 - Slope : -0.0834649 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7601 - Final Residual ratio : 0.00174142 - Residual ratio : 0.000989382 - Slope : -0.0837316 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76569 - Final Residual ratio : 0.00175146 - Residual ratio : 0.000991944 - Slope : -0.0839969 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76962 - Final Residual ratio : 0.0017633 - Residual ratio : 0.000996428 - Slope : -0.0841836 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7346 - Final Residual ratio : 0.00101957 - Residual ratio : 0.000587784 - Slope : -0.0787991 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806100e+05 Mflops = 337.58 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 486.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0376793; expected ratio = 0.0001obtained abs = 7.0438e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00718907; expected ratio = 0.001obtained abs = 2.45898; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77249 - Final Residual ratio : 0.0017605 - Residual ratio : 0.000993238 - Slope : -0.0843203 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77298 - Final Residual ratio : 0.00174761 - Residual ratio : 0.000985689 - Slope : -0.0843443 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77407 - Final Residual ratio : 0.00174283 - Residual ratio : 0.000982392 - Slope : -0.0843966 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77501 - Final Residual ratio : 0.00174266 - Residual ratio : 0.000981773 - Slope : -0.0844413 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7387 - Final Residual ratio : 0.00171271 - Residual ratio : 0.000985054 - Slope : -0.0827137 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77566 - Final Residual ratio : 0.00174116 - Residual ratio : 0.000980572 - Slope : -0.0844722 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7521 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.7961 - Final Residual ratio : 0.0200457 - Residual ratio : 0.000630444 - Slope : -1.5888 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.7116 - Final Residual ratio : 0.0102656 - Residual ratio : 0.000748683 - Slope : -0.685067 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.87923 - Final Residual ratio : 0.00293581 - Residual ratio : 0.000499352 - Slope : -0.293815 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7551 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.60291 - Final Residual ratio : 0.00209798 - Residual ratio : 0.000582301 - Slope : -0.163673 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806100e+05 Mflops = 340.77 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 476.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.031349; expected ratio = 0.0001obtained abs = 5.84881e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00502006; expected ratio = 0.001obtained abs = 1.71434; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.54227 - Final Residual ratio : 0.00315681 - Residual ratio : 0.000891183 - Slope : -0.168529 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.93088 - Final Residual ratio : 0.00217041 - Residual ratio : 0.000552144 - Slope : -0.178578 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.07965 - Final Residual ratio : 0.00207154 - Residual ratio : 0.000507773 - Slope : -0.185345 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.9204 - Final Residual ratio : 0.00354819 - Residual ratio : 0.000905059 - Slope : -0.186517 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.54153 - Final Residual ratio : 0.00267494 - Residual ratio : 0.000755307 - Slope : -0.168517 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 101.399 - Final Residual ratio : 0.0992811 - Residual ratio : 0.000979112 - Slope : -5.62777 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.1843 - Final Residual ratio : 0.047056 - Residual ratio : 0.000937663 - Slope : -2.7854 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.4733 - Final Residual ratio : 0.0193219 - Residual ratio : 0.000729864 - Slope : -1.3227 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.3494 - Final Residual ratio : 0.00860446 - Residual ratio : 0.000599641 - Slope : -0.682893 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.872 - Final Residual ratio : 0.00773957 - Residual ratio : 0.00060127 - Slope : -0.643214 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806100e+05 Mflops = 341.38 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 486.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.020104; expected ratio = 0.0001obtained abs = 3.76932e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00401419; expected ratio = 0.001obtained abs = 1.37345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.2273 - Final Residual ratio : 0.00874383 - Residual ratio : 0.000854946 - Slope : -0.537821 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.23395 - Final Residual ratio : 0.00687222 - Residual ratio : 0.00083462 - Slope : -0.433004 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.66798 - Final Residual ratio : 0.0043366 - Residual ratio : 0.000650361 - Slope : -0.333182 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.53119 - Final Residual ratio : 0.00460502 - Residual ratio : 0.000832554 - Slope : -0.307033 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.73325 - Final Residual ratio : 0.00185941 - Residual ratio : 0.000392841 - Slope : -0.262855 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.05426 - Final Residual ratio : 0.00157016 - Residual ratio : 0.000387286 - Slope : -0.22515 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.52857 - Final Residual ratio : 0.00318138 - Residual ratio : 0.000901605 - Slope : -0.185547 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.10739 - Final Residual ratio : 0.0030243 - Residual ratio : 0.000973259 - Slope : -0.147827 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.77988 - Final Residual ratio : 0.00180433 - Residual ratio : 0.000649067 - Slope : -0.126276 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.55927 - Final Residual ratio : 0.0017072 - Residual ratio : 0.000667063 - Slope : -0.116253 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.83 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0251837; expected ratio = 0.0001obtained abs = 4.77546e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0054149; expected ratio = 0.001obtained abs = 1.85776; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.34211 - Final Residual ratio : 0.00143765 - Residual ratio : 0.000613828 - Slope : -0.106394 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.20337 - Final Residual ratio : 0.00201854 - Residual ratio : 0.000916114 - Slope : -0.104826 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.1012 - Final Residual ratio : 0.00196944 - Residual ratio : 0.000937291 - Slope : -0.0999634 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02414 - Final Residual ratio : 0.00179841 - Residual ratio : 0.000888483 - Slope : -0.0963018 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.9873 - Final Residual ratio : 0.00157632 - Residual ratio : 0.000793197 - Slope : -0.0945585 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.90742 - Final Residual ratio : 0.00146564 - Residual ratio : 0.000768391 - Slope : -0.0907596 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8603 - Final Residual ratio : 0.0015765 - Residual ratio : 0.000847444 - Slope : -0.0885107 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81694 - Final Residual ratio : 0.0010381 - Residual ratio : 0.000571342 - Slope : -0.0825411 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.9237 - Final Residual ratio : 0.0281529 - Residual ratio : 0.000671527 - Slope : -2.32753 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.5633 - Final Residual ratio : 0.0368908 - Residual ratio : 0.000982097 - Slope : -1.97507 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806100e+05 Mflops = 339.40 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 490.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0262099; expected ratio = 0.0001obtained abs = 4.92419e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00499579; expected ratio = 0.001obtained abs = 1.71243; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.0613 - Final Residual ratio : 0.00577911 - Residual ratio : 0.00044246 - Slope : -0.725307 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.411 - Final Residual ratio : 0.00442987 - Residual ratio : 0.000818678 - Slope : -0.284556 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.8477 - Final Residual ratio : 0.0287111 - Residual ratio : 0.000779184 - Slope : -2.0455 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.3092 - Final Residual ratio : 0.0136726 - Residual ratio : 0.000893095 - Slope : -0.764779 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.15968 - Final Residual ratio : 0.00368639 - Residual ratio : 0.000714461 - Slope : -0.271368 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.50527 - Final Residual ratio : 0.00511164 - Residual ratio : 0.000928498 - Slope : -0.250007 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.28445 - Final Residual ratio : 0.00402445 - Residual ratio : 0.000761564 - Slope : -0.240019 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.61999 - Final Residual ratio : 0.00421911 - Residual ratio : 0.00091323 - Slope : -0.219798 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.61174 - Final Residual ratio : 0.00227248 - Residual ratio : 0.000629193 - Slope : -0.171879 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.51542 - Final Residual ratio : 0.00155924 - Residual ratio : 0.000619871 - Slope : -0.125693 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.7951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806100e+05 Mflops = 338.34 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 473.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0111176; expected ratio = 0.0001obtained abs = 2.09472e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00405818; expected ratio = 0.001obtained abs = 1.39155; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.7961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.89893 - Final Residual ratio : 0.00182023 - Residual ratio : 0.000958557 - Slope : -0.0903385 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81965 - Final Residual ratio : 0.00179494 - Residual ratio : 0.000986424 - Slope : -0.0865643 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98396 - Final Residual ratio : 0.00151452 - Residual ratio : 0.00076338 - Slope : -0.0991224 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.7991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08206 - Final Residual ratio : 0.0012637 - Residual ratio : 0.000606948 - Slope : -0.1156 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.7991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02584 - Final Residual ratio : 0.00199077 - Residual ratio : 0.000982689 - Slope : -0.106518 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 0.8011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.92803 - Final Residual ratio : 0.00122861 - Residual ratio : 0.000637235 - Slope : -0.0917526 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.79756 - Final Residual ratio : 0.001779 - Residual ratio : 0.000989672 - Slope : -0.0855136 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67756 - Final Residual ratio : 0.00127958 - Residual ratio : 0.000762763 - Slope : -0.0761945 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.58341 - Final Residual ratio : 0.00127211 - Residual ratio : 0.000803396 - Slope : -0.0719155 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50455 - Final Residual ratio : 0.00119065 - Residual ratio : 0.000791367 - Slope : -0.0683345 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.23 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0296247; expected ratio = 0.0001obtained abs = 5.59726e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00192935; expected ratio = 0.001obtained abs = 0.662248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47728 - Final Residual ratio : 0.00120899 - Residual ratio : 0.000818386 - Slope : -0.0670942 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47124 - Final Residual ratio : 0.00114741 - Residual ratio : 0.00077989 - Slope : -0.0668226 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48661 - Final Residual ratio : 0.0014595 - Residual ratio : 0.000981767 - Slope : -0.0707212 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50915 - Final Residual ratio : 0.00144962 - Residual ratio : 0.00096055 - Slope : -0.0753853 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50225 - Final Residual ratio : 0.0014321 - Residual ratio : 0.0009533 - Slope : -0.075041 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52914 - Final Residual ratio : 0.00143372 - Residual ratio : 0.000937599 - Slope : -0.0727477 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52894 - Final Residual ratio : 0.000971413 - Residual ratio : 0.000635353 - Slope : -0.0694529 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52157 - Final Residual ratio : 0.00103267 - Residual ratio : 0.000678686 - Slope : -0.0691154 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51051 - Final Residual ratio : 0.00103048 - Residual ratio : 0.000682207 - Slope : -0.0686126 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48682 - Final Residual ratio : 0.000956805 - Residual ratio : 0.000643523 - Slope : -0.0675394 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 334.14 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0184275; expected ratio = 0.0001obtained abs = 3.4882e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00226019; expected ratio = 0.001obtained abs = 0.776385; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48495 - Final Residual ratio : 0.00104972 - Residual ratio : 0.000706908 - Slope : -0.06745 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.953 - Final Residual ratio : 0.0103371 - Residual ratio : 0.000740852 - Slope : -0.697135 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.42091 - Final Residual ratio : 0.00194509 - Residual ratio : 0.000568588 - Slope : -0.155407 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.248 - Final Residual ratio : 0.00261854 - Residual ratio : 0.000806199 - Slope : -0.162269 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.74883 - Final Residual ratio : 0.00232158 - Residual ratio : 0.00084457 - Slope : -0.130786 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.25668 - Final Residual ratio : 0.00169681 - Residual ratio : 0.000751906 - Slope : -0.102499 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 96.6689 - Final Residual ratio : 0.0422343 - Residual ratio : 0.000436896 - Slope : -4.83133 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.6138 - Final Residual ratio : 0.0325136 - Residual ratio : 0.000996927 - Slope : -1.71481 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4256 - Final Residual ratio : 0.00918905 - Residual ratio : 0.00068444 - Slope : -1.11804 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8251 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0634 - Final Residual ratio : 0.00744733 - Residual ratio : 0.000740041 - Slope : -0.478855 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806100e+05 Mflops = 338.34 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 473.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0638353; expected ratio = 0.0001obtained abs = 1.196e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00664095; expected ratio = 0.001obtained abs = 2.27603; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806100e+05 Mflops = 340.16 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 486.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0270489; expected ratio = 0.0001obtained abs = 5.07127e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00278064; expected ratio = 0.001obtained abs = 0.952731; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.98129 - Final Residual ratio : 0.00676902 - Residual ratio : 0.00075368 - Slope : -0.427358 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.73165 - Final Residual ratio : 0.00513156 - Residual ratio : 0.000663709 - Slope : -0.367929 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.2958 - Final Residual ratio : 0.00611216 - Residual ratio : 0.000970831 - Slope : -0.314484 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.8322 - Final Residual ratio : 0.00324584 - Residual ratio : 0.000671711 - Slope : -0.241448 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.60187 - Final Residual ratio : 0.00316178 - Residual ratio : 0.000877818 - Slope : -0.179935 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.82592 - Final Residual ratio : 0.00266398 - Residual ratio : 0.000942692 - Slope : -0.141163 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.57017 - Final Residual ratio : 0.00220749 - Residual ratio : 0.00085889 - Slope : -0.197535 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.562 - Final Residual ratio : 0.00244197 - Residual ratio : 0.000953149 - Slope : -0.121884 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.55198 - Final Residual ratio : 0.00192796 - Residual ratio : 0.000755474 - Slope : -0.121431 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.44348 - Final Residual ratio : 0.00243609 - Residual ratio : 0.000996974 - Slope : -0.122052 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 332.97 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0273899; expected ratio = 0.0001obtained abs = 5.22314e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00613174; expected ratio = 0.001obtained abs = 2.10775; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.27139 - Final Residual ratio : 0.00184642 - Residual ratio : 0.000812903 - Slope : -0.113477 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08937 - Final Residual ratio : 0.0013965 - Residual ratio : 0.000668385 - Slope : -0.109893 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.91844 - Final Residual ratio : 0.00105012 - Residual ratio : 0.000547383 - Slope : -0.0913044 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77899 - Final Residual ratio : 0.00115653 - Residual ratio : 0.000650107 - Slope : -0.0846588 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67084 - Final Residual ratio : 0.00142514 - Residual ratio : 0.000852953 - Slope : -0.0794958 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.60716 - Final Residual ratio : 0.00144682 - Residual ratio : 0.000900235 - Slope : -0.0764625 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57616 - Final Residual ratio : 0.000976902 - Residual ratio : 0.000619799 - Slope : -0.0715991 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56921 - Final Residual ratio : 0.00104636 - Residual ratio : 0.000666805 - Slope : -0.0712804 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57313 - Final Residual ratio : 0.00109084 - Residual ratio : 0.000693416 - Slope : -0.0714565 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56293 - Final Residual ratio : 0.00115497 - Residual ratio : 0.000738977 - Slope : -0.0709897 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 351.00 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 504.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0258779; expected ratio = 0.0001obtained abs = 4.9406e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00221829; expected ratio = 0.001obtained abs = 0.763585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57044 - Final Residual ratio : 0.00117619 - Residual ratio : 0.000748953 - Slope : -0.0713302 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56387 - Final Residual ratio : 0.00128319 - Residual ratio : 0.000820522 - Slope : -0.0744087 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55285 - Final Residual ratio : 0.00154606 - Residual ratio : 0.000995628 - Slope : -0.077565 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53971 - Final Residual ratio : 0.00123201 - Residual ratio : 0.000800158 - Slope : -0.0732609 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50652 - Final Residual ratio : 0.00138532 - Residual ratio : 0.000919553 - Slope : -0.0716729 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51126 - Final Residual ratio : 0.00107241 - Residual ratio : 0.000709611 - Slope : -0.068645 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50565 - Final Residual ratio : 0.00111371 - Residual ratio : 0.000739686 - Slope : -0.0683881 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50317 - Final Residual ratio : 0.00100546 - Residual ratio : 0.000668892 - Slope : -0.0682802 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50244 - Final Residual ratio : 0.00115835 - Residual ratio : 0.000770982 - Slope : -0.0682401 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8551 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47457 - Final Residual ratio : 0.00114574 - Residual ratio : 0.000777 - Slope : -0.066974 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 340.44 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0200536; expected ratio = 0.0001obtained abs = 3.83004e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00199257; expected ratio = 0.001obtained abs = 0.686288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49671 - Final Residual ratio : 0.00115859 - Residual ratio : 0.000774093 - Slope : -0.0679794 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49766 - Final Residual ratio : 0.00112866 - Residual ratio : 0.000753616 - Slope : -0.0680242 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49779 - Final Residual ratio : 0.00111916 - Residual ratio : 0.000747207 - Slope : -0.0680304 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49677 - Final Residual ratio : 0.00140102 - Residual ratio : 0.000936027 - Slope : -0.0747686 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.45952 - Final Residual ratio : 0.00118152 - Residual ratio : 0.000809528 - Slope : -0.0694445 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8611 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48711 - Final Residual ratio : 0.00144025 - Residual ratio : 0.000968492 - Slope : -0.070746 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48676 - Final Residual ratio : 0.00113374 - Residual ratio : 0.000762562 - Slope : -0.0675283 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48675 - Final Residual ratio : 0.00115715 - Residual ratio : 0.000778306 - Slope : -0.0675269 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48688 - Final Residual ratio : 0.00112987 - Residual ratio : 0.000759893 - Slope : -0.067534 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.44441 - Final Residual ratio : 0.000977724 - Residual ratio : 0.0006769 - Slope : -0.0656108 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.07 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0165147; expected ratio = 0.0001obtained abs = 3.16824e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00191679; expected ratio = 0.001obtained abs = 0.661005; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48113 - Final Residual ratio : 0.00113871 - Residual ratio : 0.000768809 - Slope : -0.0672725 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48231 - Final Residual ratio : 0.00113581 - Residual ratio : 0.000766244 - Slope : -0.0673263 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.2454 - Final Residual ratio : 0.0464961 - Residual ratio : 0.000701877 - Slope : -3.67772 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.4799 - Final Residual ratio : 0.0161916 - Residual ratio : 0.000982506 - Slope : -0.783985 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.713 - Final Residual ratio : 0.0116463 - Residual ratio : 0.000849292 - Slope : -0.761184 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.39101 - Final Residual ratio : 0.00686963 - Residual ratio : 0.000929458 - Slope : -0.351626 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.0551 - Final Residual ratio : 0.0245931 - Residual ratio : 0.000943887 - Slope : -1.37003 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.99328 - Final Residual ratio : 0.00520286 - Residual ratio : 0.000868115 - Slope : -0.272186 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.92731 - Final Residual ratio : 0.00314962 - Residual ratio : 0.000801978 - Slope : -0.196208 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.01558 - Final Residual ratio : 0.00253358 - Residual ratio : 0.000840164 - Slope : -0.143478 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.68 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 427.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0126732; expected ratio = 0.0001obtained abs = 2.43291e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118656; expected ratio = 0.001obtained abs = 0.409432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.46056 - Final Residual ratio : 0.00145475 - Residual ratio : 0.000591226 - Slope : -0.129427 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.20209 - Final Residual ratio : 0.00131106 - Residual ratio : 0.00059537 - Slope : -0.115831 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.12918 - Final Residual ratio : 0.00160795 - Residual ratio : 0.000755196 - Slope : -0.111977 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.09524 - Final Residual ratio : 0.00204405 - Residual ratio : 0.000975571 - Slope : -0.116288 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.99561 - Final Residual ratio : 0.000963834 - Residual ratio : 0.000482977 - Slope : -0.104981 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.90942 - Final Residual ratio : 0.00147992 - Residual ratio : 0.000775064 - Slope : -0.100418 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77778 - Final Residual ratio : 0.00157714 - Residual ratio : 0.000887142 - Slope : -0.0888099 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64537 - Final Residual ratio : 0.00136257 - Residual ratio : 0.000828123 - Slope : -0.0782862 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5371 - Final Residual ratio : 0.0014733 - Residual ratio : 0.000958491 - Slope : -0.0731251 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42355 - Final Residual ratio : 0.00109203 - Residual ratio : 0.00076712 - Slope : -0.0646572 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.67 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0112548; expected ratio = 0.0001obtained abs = 2.16751e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00192719; expected ratio = 0.001obtained abs = 0.665534; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40512 - Final Residual ratio : 0.00127996 - Residual ratio : 0.000910924 - Slope : -0.0668495 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.3844 - Final Residual ratio : 0.0012493 - Residual ratio : 0.000902412 - Slope : -0.0691575 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38258 - Final Residual ratio : 0.00117719 - Residual ratio : 0.00085144 - Slope : -0.0690703 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.39295 - Final Residual ratio : 0.00121476 - Residual ratio : 0.000872074 - Slope : -0.0695868 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37128 - Final Residual ratio : 0.00115825 - Residual ratio : 0.000844651 - Slope : -0.0685058 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41443 - Final Residual ratio : 0.00115892 - Residual ratio : 0.000819354 - Slope : -0.0706635 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8921 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42152 - Final Residual ratio : 0.00133454 - Residual ratio : 0.000938818 - Slope : -0.071009 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41985 - Final Residual ratio : 0.00114467 - Residual ratio : 0.000806191 - Slope : -0.0675573 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.0422 - Final Residual ratio : 0.0241167 - Residual ratio : 0.000602281 - Slope : -1.90562 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.2213 - Final Residual ratio : 0.00751707 - Residual ratio : 0.000735429 - Slope : -0.444079 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.8951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.67 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0126093; expected ratio = 0.0001obtained abs = 2.41703e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00335401; expected ratio = 0.001obtained abs = 1.15639; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.8961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.14293 - Final Residual ratio : 0.00513692 - Residual ratio : 0.000630845 - Slope : -0.40689 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.70972 - Final Residual ratio : 0.00369247 - Residual ratio : 0.00078401 - Slope : -0.21391 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.53126 - Final Residual ratio : 0.00219429 - Residual ratio : 0.000621389 - Slope : -0.160412 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.8991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.94593 - Final Residual ratio : 0.00141072 - Residual ratio : 0.00047887 - Slope : -0.133842 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.8991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.42522 - Final Residual ratio : 0.00123887 - Residual ratio : 0.00051083 - Slope : -0.110181 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 0.9011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.93965 - Final Residual ratio : 0.000996275 - Residual ratio : 0.000513636 - Slope : -0.0881206 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.62522 - Final Residual ratio : 0.00111927 - Residual ratio : 0.000688689 - Slope : -0.073823 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5696 - Final Residual ratio : 0.00151944 - Residual ratio : 0.000968041 - Slope : -0.0712764 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.66839 - Final Residual ratio : 0.00146331 - Residual ratio : 0.000877077 - Slope : -0.0833465 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75951 - Final Residual ratio : 0.0015148 - Residual ratio : 0.00086092 - Slope : -0.083714 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.07 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 476.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0187196; expected ratio = 0.0001obtained abs = 3.63054e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00549335; expected ratio = 0.001obtained abs = 1.89884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.79715 - Final Residual ratio : 0.00178802 - Residual ratio : 0.000994917 - Slope : -0.0854935 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75021 - Final Residual ratio : 0.00122156 - Residual ratio : 0.00069795 - Slope : -0.0794993 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65936 - Final Residual ratio : 0.00136624 - Residual ratio : 0.00082335 - Slope : -0.0789522 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55755 - Final Residual ratio : 0.00140482 - Residual ratio : 0.00090194 - Slope : -0.0819024 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4575 - Final Residual ratio : 0.0011283 - Residual ratio : 0.000774135 - Slope : -0.0693512 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9111 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40557 - Final Residual ratio : 0.00131787 - Residual ratio : 0.000937606 - Slope : -0.0668691 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36907 - Final Residual ratio : 0.000958589 - Residual ratio : 0.000700177 - Slope : -0.0621868 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35401 - Final Residual ratio : 0.00115027 - Residual ratio : 0.000849528 - Slope : -0.0614937 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35208 - Final Residual ratio : 0.000778778 - Residual ratio : 0.000575984 - Slope : -0.0587524 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33606 - Final Residual ratio : 0.000829288 - Residual ratio : 0.000620695 - Slope : -0.0580537 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 333.56 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00979769; expected ratio = 0.0001obtained abs = 1.9105e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00243439; expected ratio = 0.001obtained abs = 0.842799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35883 - Final Residual ratio : 0.000902456 - Residual ratio : 0.000664142 - Slope : -0.0590403 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36204 - Final Residual ratio : 0.000927472 - Residual ratio : 0.000680941 - Slope : -0.059179 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36205 - Final Residual ratio : 0.000899947 - Residual ratio : 0.000660727 - Slope : -0.0591806 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9191 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35869 - Final Residual ratio : 0.00124412 - Residual ratio : 0.00091568 - Slope : -0.0617019 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33139 - Final Residual ratio : 0.0011655 - Residual ratio : 0.000875403 - Slope : -0.063344 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34453 - Final Residual ratio : 0.00108666 - Residual ratio : 0.000808203 - Slope : -0.0610658 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33907 - Final Residual ratio : 0.00110583 - Residual ratio : 0.000825821 - Slope : -0.0608166 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33495 - Final Residual ratio : 0.00129932 - Residual ratio : 0.000973305 - Slope : -0.0606206 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9241 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33199 - Final Residual ratio : 0.000781786 - Residual ratio : 0.00058693 - Slope : -0.0578787 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30676 - Final Residual ratio : 0.00129672 - Residual ratio : 0.000992315 - Slope : -0.0593391 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.68 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 476.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00683625; expected ratio = 0.0001obtained abs = 1.33616e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00214817; expected ratio = 0.001obtained abs = 0.744227; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32642 - Final Residual ratio : 0.00126996 - Residual ratio : 0.000957435 - Slope : -0.0602342 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.3258 - Final Residual ratio : 0.000786195 - Residual ratio : 0.000592997 - Slope : -0.0576093 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32505 - Final Residual ratio : 0.000819049 - Residual ratio : 0.000618128 - Slope : -0.0575751 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32386 - Final Residual ratio : 0.000821175 - Residual ratio : 0.000620289 - Slope : -0.0575234 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29914 - Final Residual ratio : 0.00129826 - Residual ratio : 0.000999325 - Slope : -0.0589927 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.3186 - Final Residual ratio : 0.00127511 - Residual ratio : 0.000967017 - Slope : -0.0598785 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31762 - Final Residual ratio : 0.00110657 - Residual ratio : 0.000839826 - Slope : -0.0598415 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31688 - Final Residual ratio : 0.00110936 - Residual ratio : 0.000842414 - Slope : -0.0598077 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31621 - Final Residual ratio : 0.000790932 - Residual ratio : 0.000600918 - Slope : -0.0571919 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29144 - Final Residual ratio : 0.000773517 - Residual ratio : 0.000598956 - Slope : -0.0561161 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.06 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00995595; expected ratio = 0.0001obtained abs = 1.95816e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00223938; expected ratio = 0.001obtained abs = 0.776825; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31301 - Final Residual ratio : 0.000800086 - Residual ratio : 0.000609351 - Slope : -0.0570528 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.1596 - Final Residual ratio : 0.0207181 - Residual ratio : 0.000710507 - Slope : -1.45694 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.834 - Final Residual ratio : 0.00832533 - Residual ratio : 0.000648694 - Slope : -0.582985 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.17853 - Final Residual ratio : 0.00359581 - Residual ratio : 0.000694368 - Slope : -0.258747 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36321 - Final Residual ratio : 0.00327158 - Residual ratio : 0.000972755 - Slope : -0.159997 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.87158 - Final Residual ratio : 0.00247996 - Residual ratio : 0.000863622 - Slope : -0.124744 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.54087 - Final Residual ratio : 0.00213205 - Residual ratio : 0.000839104 - Slope : -0.11038 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.19847 - Final Residual ratio : 0.00216876 - Residual ratio : 0.000986488 - Slope : -0.0954912 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.86658 - Final Residual ratio : 0.00159774 - Residual ratio : 0.000855971 - Slope : -0.0777075 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61996 - Final Residual ratio : 0.00160248 - Residual ratio : 0.000989212 - Slope : -0.0703633 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 342.29 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00644969; expected ratio = 0.0001obtained abs = 1.2724e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00155393; expected ratio = 0.001obtained abs = 0.53956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51865 - Final Residual ratio : 0.00137461 - Residual ratio : 0.000905152 - Slope : -0.0689669 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52908 - Final Residual ratio : 0.00121392 - Residual ratio : 0.000793889 - Slope : -0.0763934 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57821 - Final Residual ratio : 0.00149594 - Residual ratio : 0.000947874 - Slope : -0.0750816 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.609 - Final Residual ratio : 0.00153834 - Residual ratio : 0.000956084 - Slope : -0.0765458 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57985 - Final Residual ratio : 0.00143663 - Residual ratio : 0.000909348 - Slope : -0.0751624 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56257 - Final Residual ratio : 0.00137693 - Residual ratio : 0.000881198 - Slope : -0.0743424 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50925 - Final Residual ratio : 0.00139969 - Residual ratio : 0.000927407 - Slope : -0.0685387 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.45515 - Final Residual ratio : 0.000985117 - Residual ratio : 0.000676984 - Slope : -0.0632248 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.5734 - Final Residual ratio : 0.00751958 - Residual ratio : 0.000711182 - Slope : -0.480265 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.92368 - Final Residual ratio : 0.00160008 - Residual ratio : 0.000547284 - Slope : -0.139147 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.06 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00637594; expected ratio = 0.0001obtained abs = 1.26175e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0016045; expected ratio = 0.001obtained abs = 0.557556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70668 - Final Residual ratio : 0.00137348 - Residual ratio : 0.000804765 - Slope : -0.081205 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.60077 - Final Residual ratio : 0.001196 - Residual ratio : 0.000747138 - Slope : -0.0695469 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4212 - Final Residual ratio : 0.00134848 - Residual ratio : 0.000948832 - Slope : -0.0617328 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2991 - Final Residual ratio : 0.000924022 - Residual ratio : 0.000711278 - Slope : -0.0540907 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.23029 - Final Residual ratio : 0.00122907 - Residual ratio : 0.000999012 - Slope : -0.0534373 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9611 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15752 - Final Residual ratio : 0.00098715 - Residual ratio : 0.000852814 - Slope : -0.0502841 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13887 - Final Residual ratio : 0.000973148 - Residual ratio : 0.000854483 - Slope : -0.0517227 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15608 - Final Residual ratio : 0.000906627 - Residual ratio : 0.000784224 - Slope : -0.0607987 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19041 - Final Residual ratio : 0.00105352 - Residual ratio : 0.000885007 - Slope : -0.0594678 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24451 - Final Residual ratio : 0.000962853 - Residual ratio : 0.000773682 - Slope : -0.0592164 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.06 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 490.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.01073; expected ratio = 0.0001obtained abs = 2.14025e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00264967; expected ratio = 0.001obtained abs = 0.922082; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.23958 - Final Residual ratio : 0.000989966 - Residual ratio : 0.000798633 - Slope : -0.0589803 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.23849 - Final Residual ratio : 0.000944972 - Residual ratio : 0.000763 - Slope : -0.0589309 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22745 - Final Residual ratio : 0.000987719 - Residual ratio : 0.00080469 - Slope : -0.0584031 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2108 - Final Residual ratio : 0.00102979 - Residual ratio : 0.000850503 - Slope : -0.0576082 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21595 - Final Residual ratio : 0.00109679 - Residual ratio : 0.000902002 - Slope : -0.0578502 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18232 - Final Residual ratio : 0.00116732 - Residual ratio : 0.000987312 - Slope : -0.0590575 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17304 - Final Residual ratio : 0.00100136 - Residual ratio : 0.000853651 - Slope : -0.0586017 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17084 - Final Residual ratio : 0.00105162 - Residual ratio : 0.000898172 - Slope : -0.0584895 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17232 - Final Residual ratio : 0.00100958 - Residual ratio : 0.000861183 - Slope : -0.0585655 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19518 - Final Residual ratio : 0.00101044 - Residual ratio : 0.00084543 - Slope : -0.0597083 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.06 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 490.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00939581; expected ratio = 0.0001obtained abs = 1.88575e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00244659; expected ratio = 0.001obtained abs = 0.852562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17938 - Final Residual ratio : 0.000992431 - Residual ratio : 0.000841487 - Slope : -0.0589193 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17983 - Final Residual ratio : 0.00100497 - Residual ratio : 0.000851794 - Slope : -0.0589412 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.181 - Final Residual ratio : 0.00101248 - Residual ratio : 0.000857311 - Slope : -0.0589993 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18104 - Final Residual ratio : 0.00114714 - Residual ratio : 0.000971291 - Slope : -0.0620999 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19797 - Final Residual ratio : 0.00105929 - Residual ratio : 0.000884236 - Slope : -0.0598455 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17939 - Final Residual ratio : 0.00102087 - Residual ratio : 0.000865585 - Slope : -0.0589187 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17625 - Final Residual ratio : 0.00104905 - Residual ratio : 0.00089186 - Slope : -0.05876 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17536 - Final Residual ratio : 0.0010704 - Residual ratio : 0.000910702 - Slope : -0.0587144 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17489 - Final Residual ratio : 0.00107277 - Residual ratio : 0.000913082 - Slope : -0.0586911 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1899 - Final Residual ratio : 0.00108287 - Residual ratio : 0.000910054 - Slope : -0.0594406 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.06 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 490.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0097219; expected ratio = 0.0001obtained abs = 1.96417e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00254346; expected ratio = 0.001obtained abs = 0.887527; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17488 - Final Residual ratio : 0.00107252 - Residual ratio : 0.00091288 - Slope : -0.0586903 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17306 - Final Residual ratio : 0.0010682 - Residual ratio : 0.000910607 - Slope : -0.0585997 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17316 - Final Residual ratio : 0.00106114 - Residual ratio : 0.00090452 - Slope : -0.0586047 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17327 - Final Residual ratio : 0.00105184 - Residual ratio : 0.0008965 - Slope : -0.0586111 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18613 - Final Residual ratio : 0.00104919 - Residual ratio : 0.00088455 - Slope : -0.0592542 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17332 - Final Residual ratio : 0.00104621 - Residual ratio : 0.000891665 - Slope : -0.0586138 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17141 - Final Residual ratio : 0.00104962 - Residual ratio : 0.00089603 - Slope : -0.0585181 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17127 - Final Residual ratio : 0.00105988 - Residual ratio : 0.000904898 - Slope : -0.0585106 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17113 - Final Residual ratio : 0.00107243 - Residual ratio : 0.000915726 - Slope : -0.0585026 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1814 - Final Residual ratio : 0.00107813 - Residual ratio : 0.000912588 - Slope : -0.0590161 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 0.9951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.23 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0102083; expected ratio = 0.0001obtained abs = 2.07674e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00265391; expected ratio = 0.001obtained abs = 0.927392; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 0.9961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.4498 - Final Residual ratio : 0.00844495 - Residual ratio : 0.000546607 - Slope : -0.735301 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.01559 - Final Residual ratio : 0.00402769 - Residual ratio : 0.000669542 - Slope : -0.273253 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.8339 - Final Residual ratio : 0.00228031 - Residual ratio : 0.000804656 - Slope : -0.134839 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 0.9991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.07034 - Final Residual ratio : 0.00120082 - Residual ratio : 0.000580013 - Slope : -0.0899626 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 0.9991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.01491 - Final Residual ratio : 0.00147325 - Residual ratio : 0.000731174 - Slope : -0.0875408 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.0011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.18848 - Final Residual ratio : 0.0011822 - Residual ratio : 0.000540192 - Slope : -0.0951 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.32916 - Final Residual ratio : 0.00222861 - Residual ratio : 0.000956829 - Slope : -0.10577 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.3209 - Final Residual ratio : 0.00209748 - Residual ratio : 0.000903735 - Slope : -0.1054 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.17566 - Final Residual ratio : 0.00184976 - Residual ratio : 0.000850206 - Slope : -0.0988096 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.96106 - Final Residual ratio : 0.0017215 - Residual ratio : 0.000877844 - Slope : -0.0890606 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 338.47 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00762522; expected ratio = 0.0001obtained abs = 1.55926e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00215808; expected ratio = 0.001obtained abs = 0.75487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70769 - Final Residual ratio : 0.00145024 - Residual ratio : 0.00084924 - Slope : -0.0775564 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5 - Final Residual ratio : 0.00147803 - Residual ratio : 0.000985347 - Slope : -0.0681149 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35928 - Final Residual ratio : 0.000947568 - Residual ratio : 0.000697112 - Slope : -0.0590578 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.28235 - Final Residual ratio : 0.00118662 - Residual ratio : 0.000925348 - Slope : -0.0582345 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.25317 - Final Residual ratio : 0.00124237 - Residual ratio : 0.00099138 - Slope : -0.0596155 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22813 - Final Residual ratio : 0.00106519 - Residual ratio : 0.000867322 - Slope : -0.0613534 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21212 - Final Residual ratio : 0.000979897 - Residual ratio : 0.000808417 - Slope : -0.0637441 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19688 - Final Residual ratio : 0.00107693 - Residual ratio : 0.000899783 - Slope : -0.0629368 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18192 - Final Residual ratio : 0.000975766 - Residual ratio : 0.000825577 - Slope : -0.0562355 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17534 - Final Residual ratio : 0.000870289 - Residual ratio : 0.000740458 - Slope : -0.0533849 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 332.97 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0107021; expected ratio = 0.0001obtained abs = 2.20472e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00288326; expected ratio = 0.001obtained abs = 1.00984; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.16123 - Final Residual ratio : 0.000896649 - Residual ratio : 0.000772154 - Slope : -0.0527424 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15566 - Final Residual ratio : 0.000893392 - Residual ratio : 0.000773056 - Slope : -0.0524895 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15433 - Final Residual ratio : 0.000958502 - Residual ratio : 0.000830352 - Slope : -0.0524261 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15432 - Final Residual ratio : 0.000929356 - Residual ratio : 0.000805111 - Slope : -0.0524268 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15916 - Final Residual ratio : 0.00114967 - Residual ratio : 0.00099181 - Slope : -0.0551434 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15456 - Final Residual ratio : 0.000962378 - Residual ratio : 0.000833549 - Slope : -0.054933 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15299 - Final Residual ratio : 0.00107096 - Residual ratio : 0.000928855 - Slope : -0.057596 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15266 - Final Residual ratio : 0.000979863 - Residual ratio : 0.000850092 - Slope : -0.0548417 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15198 - Final Residual ratio : 0.00100105 - Residual ratio : 0.000868988 - Slope : -0.0548083 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15339 - Final Residual ratio : 0.00104661 - Residual ratio : 0.000907425 - Slope : -0.0548734 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 334.14 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0125996; expected ratio = 0.0001obtained abs = 2.61821e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00306655; expected ratio = 0.001obtained abs = 1.07579; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0261 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14984 - Final Residual ratio : 0.00109939 - Residual ratio : 0.000956123 - Slope : -0.0547018 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1477 - Final Residual ratio : 0.00113454 - Residual ratio : 0.000988529 - Slope : -0.0545985 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14712 - Final Residual ratio : 0.00114619 - Residual ratio : 0.000999194 - Slope : -0.05457 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14663 - Final Residual ratio : 0.00113598 - Residual ratio : 0.000990719 - Slope : -0.0545471 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14653 - Final Residual ratio : 0.00110927 - Residual ratio : 0.000967503 - Slope : -0.054544 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14541 - Final Residual ratio : 0.00108066 - Residual ratio : 0.000943475 - Slope : -0.0544917 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14393 - Final Residual ratio : 0.00105064 - Residual ratio : 0.000918447 - Slope : -0.054423 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.8533 - Final Residual ratio : 0.0169378 - Residual ratio : 0.000853145 - Slope : -0.94459 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.62747 - Final Residual ratio : 0.00240684 - Residual ratio : 0.000663506 - Slope : -0.157611 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.39881 - Final Residual ratio : 0.00113723 - Residual ratio : 0.000812998 - Slope : -0.0665556 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.06 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0153819; expected ratio = 0.0001obtained abs = 3.23045e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00377022; expected ratio = 0.001obtained abs = 1.32496; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38101 - Final Residual ratio : 0.000982325 - Residual ratio : 0.000711308 - Slope : -0.0657157 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49039 - Final Residual ratio : 0.00086611 - Residual ratio : 0.000581128 - Slope : -0.0709299 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0381 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53109 - Final Residual ratio : 0.00138356 - Residual ratio : 0.000903643 - Slope : -0.0764854 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49082 - Final Residual ratio : 0.00121678 - Residual ratio : 0.000816186 - Slope : -0.07448 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38769 - Final Residual ratio : 0.00105885 - Residual ratio : 0.000763028 - Slope : -0.0693317 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29638 - Final Residual ratio : 0.000908426 - Residual ratio : 0.000700739 - Slope : -0.0647738 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.20811 - Final Residual ratio : 0.00101224 - Residual ratio : 0.000837875 - Slope : -0.0603549 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14771 - Final Residual ratio : 0.000942008 - Residual ratio : 0.00082077 - Slope : -0.0546081 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11544 - Final Residual ratio : 0.00108677 - Residual ratio : 0.000974296 - Slope : -0.0557179 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09596 - Final Residual ratio : 0.000960352 - Residual ratio : 0.000876266 - Slope : -0.0521428 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.68 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.01726; expected ratio = 0.0001obtained abs = 3.6593e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00382158; expected ratio = 0.001obtained abs = 1.34507; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10416 - Final Residual ratio : 0.000957326 - Residual ratio : 0.00086702 - Slope : -0.05516 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10824 - Final Residual ratio : 0.000884216 - Residual ratio : 0.000797856 - Slope : -0.0553678 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11435 - Final Residual ratio : 0.00110097 - Residual ratio : 0.000987988 - Slope : -0.0585923 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11985 - Final Residual ratio : 0.000986767 - Residual ratio : 0.000881164 - Slope : -0.0559429 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0501 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11744 - Final Residual ratio : 0.00104055 - Residual ratio : 0.000931194 - Slope : -0.05582 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12768 - Final Residual ratio : 0.000915646 - Residual ratio : 0.000811975 - Slope : -0.0536553 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12887 - Final Residual ratio : 0.000942107 - Residual ratio : 0.000834556 - Slope : -0.0537109 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13075 - Final Residual ratio : 0.000960687 - Residual ratio : 0.000849605 - Slope : -0.0537993 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.132 - Final Residual ratio : 0.000966506 - Residual ratio : 0.000853808 - Slope : -0.0538585 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12494 - Final Residual ratio : 0.00112228 - Residual ratio : 0.000997635 - Slope : -0.0561909 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.07 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0237361; expected ratio = 0.0001obtained abs = 5.09631e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00398838; expected ratio = 0.001obtained abs = 1.40624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13318 - Final Residual ratio : 0.00112661 - Residual ratio : 0.000994197 - Slope : -0.0566028 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0571 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13213 - Final Residual ratio : 0.00109698 - Residual ratio : 0.000968955 - Slope : -0.0565514 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13239 - Final Residual ratio : 0.0010822 - Residual ratio : 0.00095568 - Slope : -0.0565655 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13272 - Final Residual ratio : 0.00108254 - Residual ratio : 0.000955701 - Slope : -0.056582 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1242 - Final Residual ratio : 0.00104378 - Residual ratio : 0.000928463 - Slope : -0.0561579 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1337 - Final Residual ratio : 0.00109422 - Residual ratio : 0.000965173 - Slope : -0.0566303 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13305 - Final Residual ratio : 0.00110755 - Residual ratio : 0.000977495 - Slope : -0.0565972 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13371 - Final Residual ratio : 0.00112287 - Residual ratio : 0.000990438 - Slope : -0.0566292 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13427 - Final Residual ratio : 0.000925476 - Residual ratio : 0.000815925 - Slope : -0.0539686 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12453 - Final Residual ratio : 0.00108441 - Residual ratio : 0.000964327 - Slope : -0.0561723 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.83 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0351824; expected ratio = 0.0001obtained abs = 7.68212e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00423646; expected ratio = 0.001obtained abs = 1.49688; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1349 - Final Residual ratio : 0.00111844 - Residual ratio : 0.000985496 - Slope : -0.0566892 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13383 - Final Residual ratio : 0.00111077 - Residual ratio : 0.000979659 - Slope : -0.0566361 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13396 - Final Residual ratio : 0.00110735 - Residual ratio : 0.000976528 - Slope : -0.0566428 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13404 - Final Residual ratio : 0.00110962 - Residual ratio : 0.00097847 - Slope : -0.0566464 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12267 - Final Residual ratio : 0.00105991 - Residual ratio : 0.0009441 - Slope : -0.0560806 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13406 - Final Residual ratio : 0.00111168 - Residual ratio : 0.000980271 - Slope : -0.0566473 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 91.6159 - Final Residual ratio : 0.0547274 - Residual ratio : 0.000597357 - Slope : -4.36006 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.2761 - Final Residual ratio : 0.0190667 - Residual ratio : 0.000819155 - Slope : -1.10748 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.1724 - Final Residual ratio : 0.00944397 - Residual ratio : 0.000666362 - Slope : -1.18025 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.08467 - Final Residual ratio : 0.00659771 - Residual ratio : 0.000726246 - Slope : -0.41264 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 340.44 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.103733; expected ratio = 0.0001obtained abs = 2.18303e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118813; expected ratio = 0.001obtained abs = 4.18321; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 342.44 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0155964; expected ratio = 0.0001obtained abs = 3.27918e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0061514; expected ratio = 0.001obtained abs = 2.1592; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.13408 - Final Residual ratio : 0.00534983 - Residual ratio : 0.000872148 - Slope : -0.278579 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.24004 - Final Residual ratio : 0.00411975 - Residual ratio : 0.000786205 - Slope : -0.218164 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 94.0187 - Final Residual ratio : 0.0553852 - Residual ratio : 0.000589087 - Slope : -4.94544 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.2462 - Final Residual ratio : 0.0225632 - Residual ratio : 0.000828122 - Slope : -1.36118 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.9588 - Final Residual ratio : 0.0169552 - Residual ratio : 0.000707682 - Slope : -1.19709 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.4861 - Final Residual ratio : 0.00897077 - Residual ratio : 0.000718463 - Slope : -0.594147 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.39746 - Final Residual ratio : 0.00892521 - Residual ratio : 0.000949747 - Slope : -0.447073 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.48329 - Final Residual ratio : 0.00715539 - Residual ratio : 0.000956183 - Slope : -0.356006 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.86849 - Final Residual ratio : 0.00470829 - Residual ratio : 0.000802301 - Slope : -0.279227 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0851 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.2717 - Final Residual ratio : 0.00332532 - Residual ratio : 0.000778453 - Slope : -0.213419 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.23 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 435.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0348298; expected ratio = 0.0001obtained abs = 7.42902e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00544318; expected ratio = 0.001obtained abs = 1.91708; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.44814 - Final Residual ratio : 0.0022987 - Residual ratio : 0.000666649 - Slope : -0.172292 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.87178 - Final Residual ratio : 0.0026034 - Residual ratio : 0.000906547 - Slope : -0.151009 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.60498 - Final Residual ratio : 0.00120105 - Residual ratio : 0.000461059 - Slope : -0.130189 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.4651 - Final Residual ratio : 0.0012959 - Residual ratio : 0.000525701 - Slope : -0.12319 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.17099 - Final Residual ratio : 0.00124192 - Residual ratio : 0.000572055 - Slope : -0.108487 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.12816 - Final Residual ratio : 0.001744 - Residual ratio : 0.000819487 - Slope : -0.106321 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.95129 - Final Residual ratio : 0.0017032 - Residual ratio : 0.000872857 - Slope : -0.0928375 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 45.0714 - Final Residual ratio : 0.0397554 - Residual ratio : 0.000882052 - Slope : -2.37009 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.6365 - Final Residual ratio : 0.0126933 - Residual ratio : 0.000615088 - Slope : -0.896687 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.1859 - Final Residual ratio : 0.00520747 - Residual ratio : 0.000724679 - Slope : -0.341938 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.0951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.0951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 340.44 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 490.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.018507; expected ratio = 0.0001obtained abs = 3.89252e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0061044; expected ratio = 0.001obtained abs = 2.1474; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.0961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.15018 - Final Residual ratio : 0.00566205 - Residual ratio : 0.000920632 - Slope : -0.279296 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.37938 - Final Residual ratio : 0.0032743 - Residual ratio : 0.000608676 - Slope : -0.233744 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.47419 - Final Residual ratio : 0.00444685 - Residual ratio : 0.00099389 - Slope : -0.212845 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.0991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.52233 - Final Residual ratio : 0.00271115 - Residual ratio : 0.000769705 - Slope : -0.159983 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.0991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.6107 - Final Residual ratio : 0.00150615 - Residual ratio : 0.000576915 - Slope : -0.113443 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84753 - Final Residual ratio : 0.0013263 - Residual ratio : 0.00071788 - Slope : -0.0802696 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.1021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48089 - Final Residual ratio : 0.00107408 - Residual ratio : 0.000725296 - Slope : -0.0672644 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.54247 - Final Residual ratio : 0.00108005 - Residual ratio : 0.000700208 - Slope : -0.081126 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.73302 - Final Residual ratio : 0.00138062 - Residual ratio : 0.000796653 - Slope : -0.0752887 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84635 - Final Residual ratio : 0.00136138 - Residual ratio : 0.000737337 - Slope : -0.0802168 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 339.83 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.054038; expected ratio = 0.0001obtained abs = 1.17017e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106384; expected ratio = 0.001obtained abs = 3.75366; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 343.06 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0144148; expected ratio = 0.0001obtained abs = 3.12187e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00421535; expected ratio = 0.001obtained abs = 1.48902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81989 - Final Residual ratio : 0.00131131 - Residual ratio : 0.000720542 - Slope : -0.0909292 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70274 - Final Residual ratio : 0.00154112 - Residual ratio : 0.000905084 - Slope : -0.0810093 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1081 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 75.2906 - Final Residual ratio : 0.058207 - Residual ratio : 0.000773098 - Slope : -3.76162 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.8807 - Final Residual ratio : 0.0226175 - Residual ratio : 0.000756927 - Slope : -1.42181 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.21801 - Final Residual ratio : 0.00662199 - Residual ratio : 0.00080579 - Slope : -0.391018 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.11869 - Final Residual ratio : 0.00596911 - Residual ratio : 0.000838513 - Slope : -0.323305 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.5938 - Final Residual ratio : 0.00632799 - Residual ratio : 0.000959688 - Slope : -0.299431 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.7522 - Final Residual ratio : 0.00414377 - Residual ratio : 0.000720381 - Slope : -0.239502 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.66836 - Final Residual ratio : 0.0035258 - Residual ratio : 0.000755255 - Slope : -0.194368 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.58853 - Final Residual ratio : 0.00348531 - Residual ratio : 0.000971236 - Slope : -0.155871 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.06 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.024224; expected ratio = 0.0001obtained abs = 5.18871e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00268114; expected ratio = 0.001obtained abs = 0.94606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.7004 - Final Residual ratio : 0.00249691 - Residual ratio : 0.000924645 - Slope : -0.122632 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.24046 - Final Residual ratio : 0.00222828 - Residual ratio : 0.000994563 - Slope : -0.111912 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.13715 - Final Residual ratio : 0.00175902 - Residual ratio : 0.00082307 - Slope : -0.0928431 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.13559 - Final Residual ratio : 0.00165529 - Residual ratio : 0.000775097 - Slope : -0.0927797 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08739 - Final Residual ratio : 0.00174031 - Residual ratio : 0.000833726 - Slope : -0.104282 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.91302 - Final Residual ratio : 0.00190994 - Residual ratio : 0.000998391 - Slope : -0.112418 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.71163 - Final Residual ratio : 0.000835445 - Residual ratio : 0.000488099 - Slope : -0.0855398 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50345 - Final Residual ratio : 0.00124153 - Residual ratio : 0.000825789 - Slope : -0.0682823 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33097 - Final Residual ratio : 0.0011116 - Residual ratio : 0.000835178 - Slope : -0.0578201 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22281 - Final Residual ratio : 0.00109874 - Residual ratio : 0.000898536 - Slope : -0.053118 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 340.44 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0247685; expected ratio = 0.0001obtained abs = 5.3736e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00335416; expected ratio = 0.001obtained abs = 1.18502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11774 - Final Residual ratio : 0.000869708 - Residual ratio : 0.000778093 - Slope : -0.0485597 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07159 - Final Residual ratio : 0.000683272 - Residual ratio : 0.000637622 - Slope : -0.0465614 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05907 - Final Residual ratio : 0.000835812 - Residual ratio : 0.000789195 - Slope : -0.0460101 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06846 - Final Residual ratio : 0.000962698 - Residual ratio : 0.000901012 - Slope : -0.046413 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10668 - Final Residual ratio : 0.00101332 - Residual ratio : 0.000915644 - Slope : -0.0480723 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09581 - Final Residual ratio : 0.00100979 - Residual ratio : 0.000921496 - Slope : -0.0476001 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09668 - Final Residual ratio : 0.000880992 - Residual ratio : 0.000803323 - Slope : -0.0476436 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0868 - Final Residual ratio : 0.000955342 - Residual ratio : 0.000879044 - Slope : -0.0517067 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06886 - Final Residual ratio : 0.000673813 - Residual ratio : 0.000630403 - Slope : -0.0534094 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06795 - Final Residual ratio : 0.000695815 - Residual ratio : 0.000651544 - Slope : -0.0533626 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807620e+05 Mflops = 341.67 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0327762; expected ratio = 0.0001obtained abs = 7.23019e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00407263; expected ratio = 0.001obtained abs = 1.4425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02486 - Final Residual ratio : 0.000893329 - Residual ratio : 0.000871656 - Slope : -0.0511985 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.008 - Final Residual ratio : 0.00100344 - Residual ratio : 0.000995479 - Slope : -0.0479521 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.997097 - Final Residual ratio : 0.000901797 - Residual ratio : 0.000904423 - Slope : -0.0452816 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1391 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.99185 - Final Residual ratio : 0.000710889 - Residual ratio : 0.00071673 - Slope : -0.043093 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01437 - Final Residual ratio : 0.000770778 - Residual ratio : 0.000759856 - Slope : -0.0440697 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.99169 - Final Residual ratio : 0.000782519 - Residual ratio : 0.000789077 - Slope : -0.0430829 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.994259 - Final Residual ratio : 0.000758793 - Residual ratio : 0.000763175 - Slope : -0.0431956 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.99656 - Final Residual ratio : 0.000917833 - Residual ratio : 0.000921001 - Slope : -0.0452565 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.997007 - Final Residual ratio : 0.000947222 - Residual ratio : 0.000950066 - Slope : -0.0474314 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01771 - Final Residual ratio : 0.000902417 - Residual ratio : 0.000886712 - Slope : -0.0484195 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.803560e+05 Mflops = 340.90 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0206183; expected ratio = 0.0001obtained abs = 4.5858e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00258725; expected ratio = 0.001obtained abs = 0.917405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.990458 - Final Residual ratio : 0.000868768 - Residual ratio : 0.000877138 - Slope : -0.0471233 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.985902 - Final Residual ratio : 0.000958044 - Residual ratio : 0.000971744 - Slope : -0.0469021 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.982244 - Final Residual ratio : 0.00083375 - Residual ratio : 0.000848821 - Slope : -0.0446096 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.979444 - Final Residual ratio : 0.000931958 - Residual ratio : 0.000951517 - Slope : -0.0444778 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.997064 - Final Residual ratio : 0.000996955 - Residual ratio : 0.00099989 - Slope : -0.0452758 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.975985 - Final Residual ratio : 0.000739126 - Residual ratio : 0.000757313 - Slope : -0.042402 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.975894 - Final Residual ratio : 0.000968178 - Residual ratio : 0.000992093 - Slope : -0.0443148 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.976763 - Final Residual ratio : 0.000931692 - Residual ratio : 0.000953856 - Slope : -0.044356 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.977309 - Final Residual ratio : 0.000867113 - Residual ratio : 0.000887246 - Slope : -0.0443837 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.992274 - Final Residual ratio : 0.000806009 - Residual ratio : 0.000812285 - Slope : -0.0450667 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.803560e+05 Mflops = 341.06 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0135413; expected ratio = 0.0001obtained abs = 3.03286e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0024528; expected ratio = 0.001obtained abs = 0.870421; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.974846 - Final Residual ratio : 0.000770577 - Residual ratio : 0.000790461 - Slope : -0.0442761 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.973308 - Final Residual ratio : 0.000777589 - Residual ratio : 0.000798913 - Slope : -0.0442059 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.626 - Final Residual ratio : 0.0225371 - Residual ratio : 0.000712611 - Slope : -1.37406 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.49985 - Final Residual ratio : 0.00670765 - Residual ratio : 0.000789149 - Slope : -0.326659 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.4187 - Final Residual ratio : 0.00523197 - Residual ratio : 0.00096554 - Slope : -0.270673 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.67661 - Final Residual ratio : 0.00245529 - Residual ratio : 0.000667813 - Slope : -0.146966 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.08024 - Final Residual ratio : 0.00245328 - Residual ratio : 0.000796457 - Slope : -0.118377 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.69916 - Final Residual ratio : 0.00227942 - Residual ratio : 0.000844493 - Slope : -0.103726 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.26882 - Final Residual ratio : 0.00217668 - Residual ratio : 0.00095939 - Slope : -0.0871784 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80029 - Final Residual ratio : 0.00146 - Residual ratio : 0.000810984 - Slope : -0.0691857 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.803560e+05 Mflops = 340.29 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00995374; expected ratio = 0.0001obtained abs = 2.23844e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0018753; expected ratio = 0.001obtained abs = 0.665522; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4072 - Final Residual ratio : 0.00138399 - Residual ratio : 0.000983513 - Slope : -0.0585755 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24848 - Final Residual ratio : 0.000890527 - Residual ratio : 0.000713289 - Slope : -0.0519829 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1681 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30655 - Final Residual ratio : 0.00125893 - Residual ratio : 0.000963551 - Slope : -0.0567519 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42257 - Final Residual ratio : 0.00133312 - Residual ratio : 0.000937123 - Slope : -0.0947488 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48874 - Final Residual ratio : 0.00146809 - Residual ratio : 0.00098613 - Slope : -0.0782777 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47561 - Final Residual ratio : 0.00117716 - Residual ratio : 0.000797746 - Slope : -0.0614346 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4021 - Final Residual ratio : 0.00103728 - Residual ratio : 0.000739803 - Slope : -0.0609156 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30416 - Final Residual ratio : 0.00060089 - Residual ratio : 0.000460748 - Slope : -0.0651781 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2078 - Final Residual ratio : 0.00107647 - Residual ratio : 0.000891268 - Slope : -0.054851 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12876 - Final Residual ratio : 0.000984062 - Residual ratio : 0.000871809 - Slope : -0.0490337 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804020e+05 Mflops = 339.77 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 489.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0118851; expected ratio = 0.0001obtained abs = 2.69355e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00282439; expected ratio = 0.001obtained abs = 1.00325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0762 - Final Residual ratio : 0.000749821 - Residual ratio : 0.000696732 - Slope : -0.0467586 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05098 - Final Residual ratio : 0.000592054 - Residual ratio : 0.000563337 - Slope : -0.0456688 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04515 - Final Residual ratio : 0.000699816 - Residual ratio : 0.000669585 - Slope : -0.0454109 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05044 - Final Residual ratio : 0.000869959 - Residual ratio : 0.000828185 - Slope : -0.0456335 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05208 - Final Residual ratio : 0.000955138 - Residual ratio : 0.000907858 - Slope : -0.045701 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06423 - Final Residual ratio : 0.00104312 - Residual ratio : 0.000980166 - Slope : -0.0462256 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06916 - Final Residual ratio : 0.00101572 - Residual ratio : 0.000950013 - Slope : -0.046441 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06892 - Final Residual ratio : 0.000859211 - Residual ratio : 0.000803814 - Slope : -0.0464373 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06373 - Final Residual ratio : 0.00101537 - Residual ratio : 0.000954532 - Slope : -0.0506055 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04607 - Final Residual ratio : 0.00103119 - Residual ratio : 0.000985777 - Slope : -0.0522519 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804020e+05 Mflops = 340.38 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 486.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0144997; expected ratio = 0.0001obtained abs = 3.31799e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00309208; expected ratio = 0.001obtained abs = 1.09992; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04249 - Final Residual ratio : 0.000840034 - Residual ratio : 0.000805797 - Slope : -0.0496023 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03449 - Final Residual ratio : 0.00099433 - Residual ratio : 0.00096118 - Slope : -0.049214 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02878 - Final Residual ratio : 0.000853734 - Residual ratio : 0.00082985 - Slope : -0.046724 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02504 - Final Residual ratio : 0.000818013 - Residual ratio : 0.000798029 - Slope : -0.0465556 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01458 - Final Residual ratio : 0.000971103 - Residual ratio : 0.000957147 - Slope : -0.0460732 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01929 - Final Residual ratio : 0.00101817 - Residual ratio : 0.000998905 - Slope : -0.0462849 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02037 - Final Residual ratio : 0.00100698 - Residual ratio : 0.000986878 - Slope : -0.0463346 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0212 - Final Residual ratio : 0.000932022 - Residual ratio : 0.000912674 - Slope : -0.0463757 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02104 - Final Residual ratio : 0.000919292 - Residual ratio : 0.000900346 - Slope : -0.0463693 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01212 - Final Residual ratio : 0.000836005 - Residual ratio : 0.000825995 - Slope : -0.0459674 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.1951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804020e+05 Mflops = 341.76 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 486.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0135286; expected ratio = 0.0001obtained abs = 3.12198e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0033166; expected ratio = 0.001obtained abs = 1.18111; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.1961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0145 - Final Residual ratio : 0.000850645 - Residual ratio : 0.000838485 - Slope : -0.0460751 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01317 - Final Residual ratio : 0.000861129 - Residual ratio : 0.000849937 - Slope : -0.0460139 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01183 - Final Residual ratio : 0.000894024 - Residual ratio : 0.00088357 - Slope : -0.0459517 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.1991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01056 - Final Residual ratio : 0.000929577 - Residual ratio : 0.00091986 - Slope : -0.0458924 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.1991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00202 - Final Residual ratio : 0.000921406 - Residual ratio : 0.000919546 - Slope : -0.0455046 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00562 - Final Residual ratio : 0.000975942 - Residual ratio : 0.000970488 - Slope : -0.0456656 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00598 - Final Residual ratio : 0.000976594 - Residual ratio : 0.000970792 - Slope : -0.0456818 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.2031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0063 - Final Residual ratio : 0.000957077 - Residual ratio : 0.000951087 - Slope : -0.0456973 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00618 - Final Residual ratio : 0.000930986 - Residual ratio : 0.000925272 - Slope : -0.0456929 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.997371 - Final Residual ratio : 0.00086291 - Residual ratio : 0.000865185 - Slope : -0.0452958 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804020e+05 Mflops = 338.40 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 486.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0178219; expected ratio = 0.0001obtained abs = 4.15881e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00440992; expected ratio = 0.001obtained abs = 1.5723; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0016 - Final Residual ratio : 0.00089004 - Residual ratio : 0.000888622 - Slope : -0.0454866 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00129 - Final Residual ratio : 0.000889974 - Residual ratio : 0.000888824 - Slope : -0.0454729 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00101 - Final Residual ratio : 0.000894747 - Residual ratio : 0.000893848 - Slope : -0.0454596 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0006 - Final Residual ratio : 0.000906832 - Residual ratio : 0.000906287 - Slope : -0.0454407 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.990697 - Final Residual ratio : 0.000881332 - Residual ratio : 0.000889608 - Slope : -0.0449916 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.996926 - Final Residual ratio : 0.000934139 - Residual ratio : 0.00093702 - Slope : -0.0452724 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.99732 - Final Residual ratio : 0.000944897 - Residual ratio : 0.000947435 - Slope : -0.0452898 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.997739 - Final Residual ratio : 0.000943099 - Residual ratio : 0.000945236 - Slope : -0.0453089 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.662 - Final Residual ratio : 0.018824 - Residual ratio : 0.000763279 - Slope : -1.12014 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.10336 - Final Residual ratio : 0.00412034 - Residual ratio : 0.000807379 - Slope : -0.212468 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804020e+05 Mflops = 340.38 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 473.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0532075; expected ratio = 0.0001obtained abs = 1.27681e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112483; expected ratio = 0.001obtained abs = 4.01695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804020e+05 Mflops = 341.61 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 489.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0103695; expected ratio = 0.0001obtained abs = 2.48502e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00300509; expected ratio = 0.001obtained abs = 1.07385; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81149 - Final Residual ratio : 0.00179165 - Residual ratio : 0.000989049 - Slope : -0.113106 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2171 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57703 - Final Residual ratio : 0.00109719 - Residual ratio : 0.000695734 - Slope : -0.0716333 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76679 - Final Residual ratio : 0.00160939 - Residual ratio : 0.000910912 - Slope : -0.0802353 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.85342 - Final Residual ratio : 0.00127532 - Residual ratio : 0.000688088 - Slope : -0.080528 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.78724 - Final Residual ratio : 0.0014185 - Residual ratio : 0.000793686 - Slope : -0.0811735 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61164 - Final Residual ratio : 0.0010177 - Residual ratio : 0.00063147 - Slope : -0.0732099 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.39863 - Final Residual ratio : 0.0011543 - Residual ratio : 0.000825311 - Slope : -0.0665463 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.20142 - Final Residual ratio : 0.00105707 - Residual ratio : 0.000879852 - Slope : -0.05716 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.4921 - Final Residual ratio : 0.015851 - Residual ratio : 0.000906182 - Slope : -0.8322 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.039 - Final Residual ratio : 0.0263697 - Residual ratio : 0.000940466 - Slope : -1.21794 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804020e+05 Mflops = 339.77 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 489.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0222236; expected ratio = 0.0001obtained abs = 5.30919e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00285225; expected ratio = 0.001obtained abs = 1.01941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.34213 - Final Residual ratio : 0.00689025 - Residual ratio : 0.000825958 - Slope : -0.362402 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.38864 - Final Residual ratio : 0.00608912 - Residual ratio : 0.000953118 - Slope : -0.255302 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.41549 - Final Residual ratio : 0.00492975 - Residual ratio : 0.000768413 - Slope : -0.256422 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.52623 - Final Residual ratio : 0.00349011 - Residual ratio : 0.000631553 - Slope : -0.22091 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.33636 - Final Residual ratio : 0.00301392 - Residual ratio : 0.000695033 - Slope : -0.173334 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.31244 - Final Residual ratio : 0.00233122 - Residual ratio : 0.000703776 - Slope : -0.143918 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.65092 - Final Residual ratio : 0.00262765 - Residual ratio : 0.000991223 - Slope : -0.220691 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.29027 - Final Residual ratio : 0.00214958 - Residual ratio : 0.000938568 - Slope : -0.0994836 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05897 - Final Residual ratio : 0.00182068 - Residual ratio : 0.000884268 - Slope : -0.0857145 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.86959 - Final Residual ratio : 0.00164184 - Residual ratio : 0.000878183 - Slope : -0.0849065 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804020e+05 Mflops = 340.38 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 473.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0358076; expected ratio = 0.0001obtained abs = 8.82552e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00801052; expected ratio = 0.001obtained abs = 2.87362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2361 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.62414 - Final Residual ratio : 0.00156557 - Residual ratio : 0.000963937 - Slope : -0.0705466 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42751 - Final Residual ratio : 0.00113 - Residual ratio : 0.000791588 - Slope : -0.0648354 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27586 - Final Residual ratio : 0.00105918 - Residual ratio : 0.000830171 - Slope : -0.0531167 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.16882 - Final Residual ratio : 0.000928077 - Residual ratio : 0.000794026 - Slope : -0.0486624 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12069 - Final Residual ratio : 0.00102705 - Residual ratio : 0.000916447 - Slope : -0.0466524 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03663 - Final Residual ratio : 0.000604267 - Residual ratio : 0.000582917 - Slope : -0.0414409 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00115 - Final Residual ratio : 0.000836056 - Residual ratio : 0.000835097 - Slope : -0.0434919 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.9836 - Final Residual ratio : 0.000701574 - Residual ratio : 0.000713271 - Slope : -0.0491449 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.979286 - Final Residual ratio : 0.000848638 - Residual ratio : 0.000866588 - Slope : -0.0425408 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01184 - Final Residual ratio : 0.000773737 - Residual ratio : 0.000764686 - Slope : -0.0421276 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804020e+05 Mflops = 338.55 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 486.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0189902; expected ratio = 0.0001obtained abs = 4.73628e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00440668; expected ratio = 0.001obtained abs = 1.58536; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.974588 - Final Residual ratio : 0.000806315 - Residual ratio : 0.00082734 - Slope : -0.0405742 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.966465 - Final Residual ratio : 0.000870452 - Residual ratio : 0.000900656 - Slope : -0.0419824 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.952342 - Final Residual ratio : 0.000739768 - Residual ratio : 0.000776788 - Slope : -0.041374 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.93363 - Final Residual ratio : 0.000631666 - Residual ratio : 0.00067657 - Slope : -0.0405652 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.947238 - Final Residual ratio : 0.000685503 - Residual ratio : 0.000723686 - Slope : -0.0411545 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.893449 - Final Residual ratio : 0.000639132 - Residual ratio : 0.000715354 - Slope : -0.0388178 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.880072 - Final Residual ratio : 0.000700862 - Residual ratio : 0.000796369 - Slope : -0.0399714 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.871923 - Final Residual ratio : 0.000728332 - Residual ratio : 0.000835317 - Slope : -0.0435597 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.867653 - Final Residual ratio : 0.00077725 - Residual ratio : 0.000895808 - Slope : -0.0433438 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.897302 - Final Residual ratio : 0.000854796 - Residual ratio : 0.000952629 - Slope : -0.0448223 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808080e+05 Mflops = 339.77 -Solve time = 0.00 -Solve flops = 1.660400e+04 Mflops = 477.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0204328; expected ratio = 0.0001obtained abs = 5.10635e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00310365; expected ratio = 0.001obtained abs = 1.11872; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.862121 - Final Residual ratio : 0.000728683 - Residual ratio : 0.000845222 - Slope : -0.0410187 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.862002 - Final Residual ratio : 0.000794274 - Residual ratio : 0.000921429 - Slope : -0.0410099 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.862014 - Final Residual ratio : 0.000498483 - Residual ratio : 0.000578277 - Slope : -0.0410246 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.860681 - Final Residual ratio : 0.000686706 - Residual ratio : 0.000797863 - Slope : -0.0409521 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.888409 - Final Residual ratio : 0.000868897 - Residual ratio : 0.000978037 - Slope : -0.0422638 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.85126 - Final Residual ratio : 0.00067782 - Residual ratio : 0.000796255 - Slope : -0.0386628 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.847245 - Final Residual ratio : 0.000641328 - Residual ratio : 0.000756957 - Slope : -0.038482 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.843836 - Final Residual ratio : 0.000795357 - Residual ratio : 0.000942549 - Slope : -0.0401448 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.840716 - Final Residual ratio : 0.000804987 - Residual ratio : 0.000957502 - Slope : -0.0399958 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.866714 - Final Residual ratio : 0.000648233 - Residual ratio : 0.000747921 - Slope : -0.0412412 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808080e+05 Mflops = 341.91 -Solve time = 0.00 -Solve flops = 1.660400e+04 Mflops = 487.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0248448; expected ratio = 0.0001obtained abs = 6.25476e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00350955; expected ratio = 0.001obtained abs = 1.26803; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.833297 - Final Residual ratio : 0.000575614 - Residual ratio : 0.000690767 - Slope : -0.0396534 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.832379 - Final Residual ratio : 0.000578703 - Residual ratio : 0.000695239 - Slope : -0.0396096 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.832361 - Final Residual ratio : 0.000810248 - Residual ratio : 0.000973434 - Slope : -0.0415776 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2691 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.832396 - Final Residual ratio : 0.000588479 - Residual ratio : 0.00070697 - Slope : -0.0396099 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.858374 - Final Residual ratio : 0.000713124 - Residual ratio : 0.000830785 - Slope : -0.040841 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.828144 - Final Residual ratio : 0.000815243 - Residual ratio : 0.000984423 - Slope : -0.0393966 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.827184 - Final Residual ratio : 0.000597176 - Residual ratio : 0.000721939 - Slope : -0.0375721 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.826292 - Final Residual ratio : 0.000789607 - Residual ratio : 0.000955602 - Slope : -0.0393096 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.82521 - Final Residual ratio : 0.000755747 - Residual ratio : 0.000915824 - Slope : -0.0392597 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.848353 - Final Residual ratio : 0.000742965 - Residual ratio : 0.000875773 - Slope : -0.0403624 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808080e+05 Mflops = 342.53 -Solve time = 0.00 -Solve flops = 1.660400e+04 Mflops = 473.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0192281; expected ratio = 0.0001obtained abs = 4.87546e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00344719; expected ratio = 0.001obtained abs = 1.2486; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.820162 - Final Residual ratio : 0.000720767 - Residual ratio : 0.000878811 - Slope : -0.039021 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.819413 - Final Residual ratio : 0.000661241 - Residual ratio : 0.000806969 - Slope : -0.0389882 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.819311 - Final Residual ratio : 0.000639566 - Residual ratio : 0.000780614 - Slope : -0.0389844 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2791 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.819122 - Final Residual ratio : 0.000536948 - Residual ratio : 0.000655517 - Slope : -0.0389802 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.840919 - Final Residual ratio : 0.000683615 - Residual ratio : 0.000812937 - Slope : -0.0400112 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.815951 - Final Residual ratio : 0.000760697 - Residual ratio : 0.000932282 - Slope : -0.0388186 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.815542 - Final Residual ratio : 0.00078263 - Residual ratio : 0.000959643 - Slope : -0.0387981 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.815432 - Final Residual ratio : 0.000772426 - Residual ratio : 0.000947259 - Slope : -0.0387933 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.81502 - Final Residual ratio : 0.00054236 - Residual ratio : 0.000665456 - Slope : -0.0387847 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.834108 - Final Residual ratio : 0.000694242 - Residual ratio : 0.000832317 - Slope : -0.0396864 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 341.17 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0249514; expected ratio = 0.0001obtained abs = 6.3816e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0036417; expected ratio = 0.001obtained abs = 1.32245; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.811542 - Final Residual ratio : 0.000710946 - Residual ratio : 0.000876044 - Slope : -0.038611 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.811084 - Final Residual ratio : 0.0006882 - Residual ratio : 0.000848494 - Slope : -0.0385903 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.811125 - Final Residual ratio : 0.00067162 - Residual ratio : 0.000828011 - Slope : -0.038593 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.811018 - Final Residual ratio : 0.000681814 - Residual ratio : 0.000840689 - Slope : -0.0385874 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.827966 - Final Residual ratio : 0.000540094 - Residual ratio : 0.000652314 - Slope : -0.0394012 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.808325 - Final Residual ratio : 0.000692793 - Residual ratio : 0.000857073 - Slope : -0.0384587 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.807981 - Final Residual ratio : 0.000754295 - Residual ratio : 0.000933555 - Slope : -0.0384393 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.808019 - Final Residual ratio : 0.00076023 - Residual ratio : 0.000940858 - Slope : -0.0384409 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.807843 - Final Residual ratio : 0.000728657 - Residual ratio : 0.000901978 - Slope : -0.038434 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.822199 - Final Residual ratio : 0.000576395 - Residual ratio : 0.00070104 - Slope : -0.0391249 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.2951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 338.44 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 478.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0278734; expected ratio = 0.0001obtained abs = 7.1964e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00391208; expected ratio = 0.001obtained abs = 1.42473; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.2961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.805174 - Final Residual ratio : 0.000702564 - Residual ratio : 0.000872562 - Slope : -0.0383082 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.804814 - Final Residual ratio : 0.000689565 - Residual ratio : 0.000856801 - Slope : -0.0382916 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.804918 - Final Residual ratio : 0.000682458 - Residual ratio : 0.000847861 - Slope : -0.0382969 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.2991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.804877 - Final Residual ratio : 0.000687373 - Residual ratio : 0.00085401 - Slope : -0.0382947 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.2991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.816875 - Final Residual ratio : 0.000653048 - Residual ratio : 0.000799446 - Slope : -0.0388677 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.6344 - Final Residual ratio : 0.0205832 - Residual ratio : 0.000951409 - Slope : -0.982446 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0263 - Final Residual ratio : 0.0111493 - Residual ratio : 0.000927077 - Slope : -0.50063 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48516 - Final Residual ratio : 0.00402591 - Residual ratio : 0.000897608 - Slope : -0.213387 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.3041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.36639 - Final Residual ratio : 0.00229919 - Residual ratio : 0.000971602 - Slope : -0.0945638 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.32635 - Final Residual ratio : 0.00189924 - Residual ratio : 0.000816405 - Slope : -0.0968521 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 332.39 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0391022; expected ratio = 0.0001obtained abs = 9.88128e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00978111; expected ratio = 0.001obtained abs = 3.54114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.75414 - Final Residual ratio : 0.00243078 - Residual ratio : 0.000882592 - Slope : -0.110068 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.98482 - Final Residual ratio : 0.00245647 - Residual ratio : 0.000822987 - Slope : -0.119294 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.94346 - Final Residual ratio : 0.00279996 - Residual ratio : 0.000951248 - Slope : -0.122527 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.69596 - Final Residual ratio : 0.00179185 - Residual ratio : 0.000664642 - Slope : -0.112257 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.32722 - Final Residual ratio : 0.00172429 - Residual ratio : 0.000740923 - Slope : -0.101109 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.93328 - Final Residual ratio : 0.00183955 - Residual ratio : 0.000951517 - Slope : -0.0877927 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5755 - Final Residual ratio : 0.00150645 - Residual ratio : 0.000956173 - Slope : -0.0715453 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3131 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29735 - Final Residual ratio : 0.00113799 - Residual ratio : 0.000877162 - Slope : -0.0589189 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11361 - Final Residual ratio : 0.000840686 - Residual ratio : 0.000754918 - Slope : -0.0529891 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00862 - Final Residual ratio : 0.00068536 - Residual ratio : 0.0006795 - Slope : -0.0503969 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 342.39 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 492.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0405616; expected ratio = 0.0001obtained abs = 1.05097e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115663; expected ratio = 0.001obtained abs = 4.20638; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 343.63 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 492.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.020007; expected ratio = 0.0001obtained abs = 5.24183e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00686409; expected ratio = 0.001obtained abs = 2.50704; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.947852 - Final Residual ratio : 0.000681501 - Residual ratio : 0.000718996 - Slope : -0.0451033 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.909947 - Final Residual ratio : 0.00081559 - Residual ratio : 0.000896305 - Slope : -0.0413242 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.879853 - Final Residual ratio : 0.000699153 - Residual ratio : 0.000794625 - Slope : -0.0382241 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.854341 - Final Residual ratio : 0.000753731 - Residual ratio : 0.000882237 - Slope : -0.0371125 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.836726 - Final Residual ratio : 0.000697948 - Residual ratio : 0.000834141 - Slope : -0.0363491 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.81929 - Final Residual ratio : 0.000715871 - Residual ratio : 0.000873769 - Slope : -0.0355902 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.810938 - Final Residual ratio : 0.000667531 - Residual ratio : 0.000823159 - Slope : -0.0352291 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.806743 - Final Residual ratio : 0.000587478 - Residual ratio : 0.00072821 - Slope : -0.0350502 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.804351 - Final Residual ratio : 0.000736047 - Residual ratio : 0.000915081 - Slope : -0.0365279 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.802576 - Final Residual ratio : 0.000631241 - Residual ratio : 0.000786518 - Slope : -0.0364521 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 343.01 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0147193; expected ratio = 0.0001obtained abs = 3.85002e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0031795; expected ratio = 0.001obtained abs = 1.162; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.4468 - Final Residual ratio : 0.0182679 - Residual ratio : 0.000747253 - Slope : -1.16326 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.5427 - Final Residual ratio : 0.0237173 - Residual ratio : 0.000802812 - Slope : -1.40567 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.07911 - Final Residual ratio : 0.00732273 - Residual ratio : 0.000806548 - Slope : -0.453589 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.59233 - Final Residual ratio : 0.00320599 - Residual ratio : 0.000698119 - Slope : -0.176505 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3301 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.88318 - Final Residual ratio : 0.00436165 - Residual ratio : 0.000893199 - Slope : -0.195153 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.41633 - Final Residual ratio : 0.00325224 - Residual ratio : 0.000736413 - Slope : -0.176523 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47404 - Final Residual ratio : 0.00306008 - Residual ratio : 0.000880843 - Slope : -0.144624 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.50156 - Final Residual ratio : 0.00197399 - Residual ratio : 0.000789104 - Slope : -0.108678 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.74867 - Final Residual ratio : 0.00168862 - Residual ratio : 0.000965661 - Slope : -0.0831895 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29042 - Final Residual ratio : 0.000956678 - Residual ratio : 0.000741371 - Slope : -0.0560635 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 336.05 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0193889; expected ratio = 0.0001obtained abs = 5.11147e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00465677; expected ratio = 0.001obtained abs = 1.70702; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06058 - Final Residual ratio : 0.0010334 - Residual ratio : 0.000974371 - Slope : -0.0460674 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 77.5358 - Final Residual ratio : 0.0583357 - Residual ratio : 0.00075237 - Slope : -3.36859 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.4801 - Final Residual ratio : 0.0169656 - Residual ratio : 0.000665838 - Slope : -1.01852 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.64844 - Final Residual ratio : 0.00648414 - Residual ratio : 0.00067204 - Slope : -0.438271 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.64891 - Final Residual ratio : 0.0067196 - Residual ratio : 0.000878504 - Slope : -0.305687 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.93129 - Final Residual ratio : 0.00404709 - Residual ratio : 0.000583887 - Slope : -0.266432 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.04258 - Final Residual ratio : 0.00543091 - Residual ratio : 0.000898774 - Slope : -0.241486 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.00093 - Final Residual ratio : 0.00494888 - Residual ratio : 0.000989591 - Slope : -0.208166 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.95524 - Final Residual ratio : 0.00331406 - Residual ratio : 0.000837891 - Slope : -0.164664 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3451 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.06024 - Final Residual ratio : 0.00248647 - Residual ratio : 0.000812506 - Slope : -0.132946 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 343.63 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0277673; expected ratio = 0.0001obtained abs = 7.21502e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00734385; expected ratio = 0.001obtained abs = 2.68439; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.44599 - Final Residual ratio : 0.00196967 - Residual ratio : 0.000805263 - Slope : -0.106262 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.13234 - Final Residual ratio : 0.00199476 - Residual ratio : 0.00093548 - Slope : -0.0968339 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00768 - Final Residual ratio : 0.00157843 - Residual ratio : 0.000786198 - Slope : -0.0911862 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.92833 - Final Residual ratio : 0.00179525 - Residual ratio : 0.000930986 - Slope : -0.0875698 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81744 - Final Residual ratio : 0.00160318 - Residual ratio : 0.000882111 - Slope : -0.121056 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.68104 - Final Residual ratio : 0.00149241 - Residual ratio : 0.00088779 - Slope : -0.0763432 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52716 - Final Residual ratio : 0.00142734 - Residual ratio : 0.000934632 - Slope : -0.0635724 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37771 - Final Residual ratio : 0.00105389 - Residual ratio : 0.000764958 - Slope : -0.0550664 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24747 - Final Residual ratio : 0.00102301 - Residual ratio : 0.000820068 - Slope : -0.0498579 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13702 - Final Residual ratio : 0.000902634 - Residual ratio : 0.000793858 - Slope : -0.0454448 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 343.63 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0187537; expected ratio = 0.0001obtained abs = 4.90842e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00631009; expected ratio = 0.001obtained abs = 2.30741; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06743 - Final Residual ratio : 0.000815047 - Residual ratio : 0.000763558 - Slope : -0.0444424 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02201 - Final Residual ratio : 0.000472721 - Residual ratio : 0.000462541 - Slope : -0.042564 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3581 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.99885 - Final Residual ratio : 0.000748112 - Residual ratio : 0.000748974 - Slope : -0.0415876 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.988913 - Final Residual ratio : 0.000923954 - Residual ratio : 0.000934313 - Slope : -0.0411662 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.980579 - Final Residual ratio : 0.000875714 - Residual ratio : 0.000893058 - Slope : -0.040821 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.91571 - Final Residual ratio : 0.00368387 - Residual ratio : 0.000940792 - Slope : -0.326002 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.23681 - Final Residual ratio : 0.00139984 - Residual ratio : 0.000625819 - Slope : -0.10161 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33116 - Final Residual ratio : 0.00129269 - Residual ratio : 0.000971096 - Slope : -0.0604487 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19928 - Final Residual ratio : 0.000854568 - Residual ratio : 0.000712567 - Slope : -0.0570679 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06955 - Final Residual ratio : 0.000943127 - Residual ratio : 0.000881794 - Slope : -0.0464613 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 342.39 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0338513; expected ratio = 0.0001obtained abs = 9.10554e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0070676; expected ratio = 0.001obtained abs = 2.59837; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3661 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05713 - Final Residual ratio : 0.00101931 - Residual ratio : 0.000964226 - Slope : -0.0440047 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00111 - Final Residual ratio : 0.000698865 - Residual ratio : 0.000698093 - Slope : -0.0400163 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.945023 - Final Residual ratio : 0.000667767 - Residual ratio : 0.000706614 - Slope : -0.0377742 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.900631 - Final Residual ratio : 0.000816905 - Residual ratio : 0.000907036 - Slope : -0.0374923 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.871019 - Final Residual ratio : 0.000634086 - Residual ratio : 0.000727982 - Slope : -0.0378428 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.8712 - Final Residual ratio : 0.000818982 - Residual ratio : 0.000940062 - Slope : -0.0414467 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.878449 - Final Residual ratio : 0.000718611 - Residual ratio : 0.000818044 - Slope : -0.0417967 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.88808 - Final Residual ratio : 0.000737198 - Residual ratio : 0.000830103 - Slope : -0.0422544 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.893488 - Final Residual ratio : 0.000599013 - Residual ratio : 0.000670421 - Slope : -0.0425185 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3751 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.883288 - Final Residual ratio : 0.000572865 - Residual ratio : 0.00064856 - Slope : -0.0420341 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 343.01 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00975276; expected ratio = 0.0001obtained abs = 2.62953e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00257976; expected ratio = 0.001obtained abs = 0.950074; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.884391 - Final Residual ratio : 0.000444309 - Residual ratio : 0.00050239 - Slope : -0.0420927 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.875554 - Final Residual ratio : 0.00073444 - Residual ratio : 0.000838829 - Slope : -0.0416581 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.866214 - Final Residual ratio : 0.000826999 - Residual ratio : 0.000954729 - Slope : -0.0393358 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.858378 - Final Residual ratio : 0.000758915 - Residual ratio : 0.000884127 - Slope : -0.0372878 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3801 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.842279 - Final Residual ratio : 0.000688709 - Residual ratio : 0.000817674 - Slope : -0.0365909 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.849114 - Final Residual ratio : 0.000662798 - Residual ratio : 0.000780577 - Slope : -0.0368892 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.849399 - Final Residual ratio : 0.000714973 - Residual ratio : 0.00084174 - Slope : -0.0385766 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.850591 - Final Residual ratio : 0.000693675 - Residual ratio : 0.000815521 - Slope : -0.0404713 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.851988 - Final Residual ratio : 0.000551446 - Residual ratio : 0.000647246 - Slope : -0.0405446 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.840194 - Final Residual ratio : 0.0004255 - Residual ratio : 0.000506431 - Slope : -0.039989 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 333.56 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 478.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0111151; expected ratio = 0.0001obtained abs = 3.01883e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00292131; expected ratio = 0.001obtained abs = 1.07734; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.851152 - Final Residual ratio : 0.000465105 - Residual ratio : 0.000546442 - Slope : -0.0405089 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.851185 - Final Residual ratio : 0.00053556 - Residual ratio : 0.000629194 - Slope : -0.0405071 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.8503 - Final Residual ratio : 0.000639941 - Residual ratio : 0.000752607 - Slope : -0.04046 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.849069 - Final Residual ratio : 0.000747477 - Residual ratio : 0.000880349 - Slope : -0.0403963 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.833678 - Final Residual ratio : 0.000770459 - Residual ratio : 0.000924168 - Slope : -0.0396623 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.844964 - Final Residual ratio : 0.000652833 - Residual ratio : 0.000772617 - Slope : -0.0383778 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.844836 - Final Residual ratio : 0.000837242 - Residual ratio : 0.000991011 - Slope : -0.0401904 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.844625 - Final Residual ratio : 0.000777213 - Residual ratio : 0.000920187 - Slope : -0.0401832 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.84432 - Final Residual ratio : 0.000703236 - Residual ratio : 0.000832903 - Slope : -0.0401722 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.828551 - Final Residual ratio : 0.000564777 - Residual ratio : 0.000681644 - Slope : -0.0394279 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.3951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 341.78 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0135482; expected ratio = 0.0001obtained abs = 3.71979e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00308859; expected ratio = 0.001obtained abs = 1.14111; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.3961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.841654 - Final Residual ratio : 0.000581545 - Residual ratio : 0.000690955 - Slope : -0.040051 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.841867 - Final Residual ratio : 0.000577491 - Residual ratio : 0.000685965 - Slope : -0.0400614 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.841563 - Final Residual ratio : 0.00059941 - Residual ratio : 0.000712258 - Slope : -0.0400459 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.3991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.841122 - Final Residual ratio : 0.000641982 - Residual ratio : 0.000763245 - Slope : -0.0400229 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.3991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.824096 - Final Residual ratio : 0.000640578 - Residual ratio : 0.00077731 - Slope : -0.0392121 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.838399 - Final Residual ratio : 0.000719027 - Residual ratio : 0.000857619 - Slope : -0.0398895 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.838764 - Final Residual ratio : 0.00073987 - Residual ratio : 0.000882096 - Slope : -0.0399059 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.838662 - Final Residual ratio : 0.000733451 - Residual ratio : 0.00087455 - Slope : -0.0399014 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.838406 - Final Residual ratio : 0.000708396 - Residual ratio : 0.000844932 - Slope : -0.0398903 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.4051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.820426 - Final Residual ratio : 0.000614477 - Residual ratio : 0.000748974 - Slope : -0.0390386 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 342.39 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 478.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00961155; expected ratio = 0.0001obtained abs = 2.65612e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00269119; expected ratio = 0.001obtained abs = 0.995528; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.835828 - Final Residual ratio : 0.000632323 - Residual ratio : 0.000756523 - Slope : -0.0397712 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.836129 - Final Residual ratio : 0.000614185 - Residual ratio : 0.000734558 - Slope : -0.0397864 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4081 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.835956 - Final Residual ratio : 0.000607708 - Residual ratio : 0.000726962 - Slope : -0.0397785 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.835676 - Final Residual ratio : 0.000616855 - Residual ratio : 0.000738151 - Slope : -0.0397647 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.816755 - Final Residual ratio : 0.000589832 - Residual ratio : 0.000722165 - Slope : -0.038865 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.833337 - Final Residual ratio : 0.000655722 - Residual ratio : 0.000786863 - Slope : -0.0396515 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.833814 - Final Residual ratio : 0.000679859 - Residual ratio : 0.000815361 - Slope : -0.0396731 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.833831 - Final Residual ratio : 0.000690026 - Residual ratio : 0.000827537 - Slope : -0.0396734 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.833692 - Final Residual ratio : 0.000687231 - Residual ratio : 0.000824322 - Slope : -0.0396669 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.513 - Final Residual ratio : 0.0200777 - Residual ratio : 0.000819061 - Slope : -1.06491 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 343.63 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0162559; expected ratio = 0.0001obtained abs = 4.5555e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00394686; expected ratio = 0.001obtained abs = 1.46274; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.47933 - Final Residual ratio : 0.00533621 - Residual ratio : 0.000823574 - Slope : -0.26975 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.20678 - Final Residual ratio : 0.00191988 - Residual ratio : 0.000869993 - Slope : -0.104993 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4181 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.843 - Final Residual ratio : 0.00144196 - Residual ratio : 0.000782398 - Slope : -0.080068 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.95925 - Final Residual ratio : 0.00157406 - Residual ratio : 0.000803402 - Slope : -0.0851163 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.01555 - Final Residual ratio : 0.00156159 - Residual ratio : 0.000774771 - Slope : -0.0915448 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.94867 - Final Residual ratio : 0.00128205 - Residual ratio : 0.000657908 - Slope : -0.0885177 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4221 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76265 - Final Residual ratio : 0.0011409 - Residual ratio : 0.000647261 - Slope : -0.0800687 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51903 - Final Residual ratio : 0.00145613 - Residual ratio : 0.000958591 - Slope : -0.0722653 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27266 - Final Residual ratio : 0.00101752 - Residual ratio : 0.000799517 - Slope : -0.0605546 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03244 - Final Residual ratio : 0.000794746 - Residual ratio : 0.000769778 - Slope : -0.044854 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 334.87 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00994768; expected ratio = 0.0001obtained abs = 2.80704e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00303643; expected ratio = 0.001obtained abs = 1.12726; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.913898 - Final Residual ratio : 0.000710252 - Residual ratio : 0.000777168 - Slope : -0.0397038 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.833625 - Final Residual ratio : 0.000590225 - Residual ratio : 0.000708022 - Slope : -0.0347098 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.795968 - Final Residual ratio : 0.000671499 - Residual ratio : 0.000843626 - Slope : -0.0345781 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.783378 - Final Residual ratio : 0.000768995 - Residual ratio : 0.00098164 - Slope : -0.0372671 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.751672 - Final Residual ratio : 0.000222033 - Residual ratio : 0.000295386 - Slope : -0.0357833 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.786402 - Final Residual ratio : 0.000218704 - Residual ratio : 0.000278107 - Slope : -0.0374373 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.794152 - Final Residual ratio : 0.000220194 - Residual ratio : 0.000277269 - Slope : -0.0378063 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.801157 - Final Residual ratio : 0.00042771 - Residual ratio : 0.000533865 - Slope : -0.03813 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.4004 - Final Residual ratio : 0.0273451 - Residual ratio : 0.000564978 - Slope : -2.41865 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.0037 - Final Residual ratio : 0.0145206 - Residual ratio : 0.000580736 - Slope : -1.24946 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 342.39 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0224998; expected ratio = 0.0001obtained abs = 6.22895e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0061846; expected ratio = 0.001obtained abs = 2.29457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.9581 - Final Residual ratio : 0.0118487 - Residual ratio : 0.00084888 - Slope : -0.697311 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.66017 - Final Residual ratio : 0.00666033 - Residual ratio : 0.000869475 - Slope : -0.382676 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.51527 - Final Residual ratio : 0.00531785 - Residual ratio : 0.000816213 - Slope : -0.309998 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.42512 - Final Residual ratio : 0.005022 - Residual ratio : 0.000925694 - Slope : -0.2581 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.47233 - Final Residual ratio : 0.0035227 - Residual ratio : 0.000787667 - Slope : -0.203127 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.75017 - Final Residual ratio : 0.00313781 - Residual ratio : 0.00083671 - Slope : -0.17843 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.22833 - Final Residual ratio : 0.00192099 - Residual ratio : 0.00059504 - Slope : -0.153639 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.82855 - Final Residual ratio : 0.00185717 - Residual ratio : 0.000656578 - Slope : -0.134605 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.49124 - Final Residual ratio : 0.00216661 - Residual ratio : 0.00086969 - Slope : -0.118527 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.19497 - Final Residual ratio : 0.00191907 - Residual ratio : 0.000874307 - Slope : -0.099684 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 344.25 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0448002; expected ratio = 0.0001obtained abs = 1.29077e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0130181; expected ratio = 0.001obtained abs = 4.84468; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 345.50 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 492.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0145529; expected ratio = 0.0001obtained abs = 4.21527e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00625066; expected ratio = 0.001obtained abs = 2.33209; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.93261 - Final Residual ratio : 0.0017789 - Residual ratio : 0.000920465 - Slope : -0.083949 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7143 - Final Residual ratio : 0.00149181 - Residual ratio : 0.000870217 - Slope : -0.0744698 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4481 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.54125 - Final Residual ratio : 0.00141023 - Residual ratio : 0.00091499 - Slope : -0.0733256 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40847 - Final Residual ratio : 0.0010155 - Residual ratio : 0.000720998 - Slope : -0.0670215 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30974 - Final Residual ratio : 0.000949185 - Residual ratio : 0.00072471 - Slope : -0.0623236 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2357 - Final Residual ratio : 0.00084584 - Residual ratio : 0.000684505 - Slope : -0.0588024 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1805 - Final Residual ratio : 0.000780419 - Residual ratio : 0.000661091 - Slope : -0.0561771 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13863 - Final Residual ratio : 0.000696549 - Residual ratio : 0.000611741 - Slope : -0.0541875 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10353 - Final Residual ratio : 0.000688661 - Residual ratio : 0.000624051 - Slope : -0.0525164 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06769 - Final Residual ratio : 0.000663715 - Residual ratio : 0.000621634 - Slope : -0.050811 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 343.01 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0136298; expected ratio = 0.0001obtained abs = 3.96849e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00522532; expected ratio = 0.001obtained abs = 1.95001; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03872 - Final Residual ratio : 0.000839004 - Residual ratio : 0.000807727 - Slope : -0.0494231 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00696 - Final Residual ratio : 0.000812007 - Residual ratio : 0.000806395 - Slope : -0.0479118 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.977049 - Final Residual ratio : 0.000745211 - Residual ratio : 0.000762716 - Slope : -0.0464907 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.949929 - Final Residual ratio : 0.000885732 - Residual ratio : 0.000932419 - Slope : -0.0451926 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.921077 - Final Residual ratio : 0.000638062 - Residual ratio : 0.000692735 - Slope : -0.0438304 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.906446 - Final Residual ratio : 0.000683354 - Residual ratio : 0.000753882 - Slope : -0.0431316 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.890656 - Final Residual ratio : 0.000636398 - Residual ratio : 0.000714527 - Slope : -0.0423819 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.878222 - Final Residual ratio : 0.000613812 - Residual ratio : 0.000698925 - Slope : -0.0417909 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.868347 - Final Residual ratio : 0.000600684 - Residual ratio : 0.000691756 - Slope : -0.0413213 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.853561 - Final Residual ratio : 0.000485681 - Residual ratio : 0.000569006 - Slope : -0.0406226 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 341.63 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0204432; expected ratio = 0.0001obtained abs = 6.05561e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00483053; expected ratio = 0.001obtained abs = 1.80689; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.852378 - Final Residual ratio : 0.000492259 - Residual ratio : 0.000577512 - Slope : -0.040566 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.84563 - Final Residual ratio : 0.000472892 - Residual ratio : 0.000559219 - Slope : -0.0402456 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.838925 - Final Residual ratio : 0.000474679 - Residual ratio : 0.000565818 - Slope : -0.0399262 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4691 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.832296 - Final Residual ratio : 0.000497427 - Residual ratio : 0.000597656 - Slope : -0.0396095 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.81852 - Final Residual ratio : 0.000425356 - Residual ratio : 0.000519665 - Slope : -0.0389569 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.819022 - Final Residual ratio : 0.000514674 - Residual ratio : 0.000628401 - Slope : -0.0389765 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.813387 - Final Residual ratio : 0.000524127 - Residual ratio : 0.000644377 - Slope : -0.0387077 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.808208 - Final Residual ratio : 0.000529785 - Residual ratio : 0.000655506 - Slope : -0.0384609 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.803695 - Final Residual ratio : 0.0005392 - Residual ratio : 0.000670902 - Slope : -0.0382455 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.1479 - Final Residual ratio : 0.019007 - Residual ratio : 0.000726903 - Slope : -1.18768 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 341.78 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00753797; expected ratio = 0.0001obtained abs = 2.23644e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00264941; expected ratio = 0.001obtained abs = 0.992546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.6084 - Final Residual ratio : 0.0225792 - Residual ratio : 0.000998709 - Slope : -1.12929 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.6864 - Final Residual ratio : 0.00633668 - Residual ratio : 0.000729495 - Slope : -0.434003 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.87445 - Final Residual ratio : 0.00284692 - Residual ratio : 0.000990425 - Slope : -0.124852 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.53495 - Final Residual ratio : 0.00211035 - Residual ratio : 0.000832504 - Slope : -0.110123 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.37504 - Final Residual ratio : 0.00236016 - Residual ratio : 0.000993733 - Slope : -0.10316 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05868 - Final Residual ratio : 0.00192144 - Residual ratio : 0.000933337 - Slope : -0.0856982 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75986 - Final Residual ratio : 0.00127976 - Residual ratio : 0.000727197 - Slope : -0.073274 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51326 - Final Residual ratio : 0.00124041 - Residual ratio : 0.000819698 - Slope : -0.0687281 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32827 - Final Residual ratio : 0.00130374 - Residual ratio : 0.000981535 - Slope : -0.0631888 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22331 - Final Residual ratio : 0.0011535 - Residual ratio : 0.000942931 - Slope : -0.058198 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 343.63 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00818338; expected ratio = 0.0001obtained abs = 2.41425e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00195145; expected ratio = 0.001obtained abs = 0.731063; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4861 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14192 - Final Residual ratio : 0.000840183 - Residual ratio : 0.000735762 - Slope : -0.0518674 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1061 - Final Residual ratio : 0.000972289 - Residual ratio : 0.000879025 - Slope : -0.0736751 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08188 - Final Residual ratio : 0.000909792 - Residual ratio : 0.000840936 - Slope : -0.0514748 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05457 - Final Residual ratio : 0.000953252 - Residual ratio : 0.00090392 - Slope : -0.0752587 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02238 - Final Residual ratio : 0.000775416 - Residual ratio : 0.000758444 - Slope : -0.0464365 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.981401 - Final Residual ratio : 0.0008259 - Residual ratio : 0.000841552 - Slope : -0.0445716 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.940927 - Final Residual ratio : 0.000732877 - Residual ratio : 0.000778889 - Slope : -0.0427361 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.90527 - Final Residual ratio : 0.000753825 - Residual ratio : 0.000832708 - Slope : -0.0411144 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.875831 - Final Residual ratio : 0.000737683 - Residual ratio : 0.000842266 - Slope : -0.039777 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.849183 - Final Residual ratio : 0.000800921 - Residual ratio : 0.000943166 - Slope : -0.0385628 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.4951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 341.17 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0170639; expected ratio = 0.0001obtained abs = 5.10815e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00395055; expected ratio = 0.001obtained abs = 1.48345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.4961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.838492 - Final Residual ratio : 0.000745786 - Residual ratio : 0.000889438 - Slope : -0.0380794 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.830277 - Final Residual ratio : 0.000624364 - Residual ratio : 0.000751994 - Slope : -0.0377115 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.82781 - Final Residual ratio : 0.000690345 - Residual ratio : 0.000833941 - Slope : -0.0393867 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.4991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.828096 - Final Residual ratio : 0.00054002 - Residual ratio : 0.000652121 - Slope : -0.0394075 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.4991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.4352 - Final Residual ratio : 0.0310182 - Residual ratio : 0.000986734 - Slope : -1.3654 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5011 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.75227 - Final Residual ratio : 0.00800248 - Residual ratio : 0.000914332 - Slope : -0.323862 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.48556 - Final Residual ratio : 0.00619297 - Residual ratio : 0.000954886 - Slope : -0.323968 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.67614 - Final Residual ratio : 0.00285726 - Residual ratio : 0.000777246 - Slope : -0.14128 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.78058 - Final Residual ratio : 0.0019663 - Residual ratio : 0.000707154 - Slope : -0.0992361 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.34777 - Final Residual ratio : 0.00186783 - Residual ratio : 0.000795577 - Slope : -0.0837823 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 343.78 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0180084; expected ratio = 0.0001obtained abs = 5.33012e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0053996; expected ratio = 0.001obtained abs = 2.02273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.5061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.93649 - Final Residual ratio : 0.0013585 - Residual ratio : 0.000701528 - Slope : -0.069112 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51454 - Final Residual ratio : 0.00055691 - Residual ratio : 0.000367708 - Slope : -0.0560736 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1871 - Final Residual ratio : 0.0008963 - Residual ratio : 0.000755035 - Slope : -0.0456231 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06883 - Final Residual ratio : 0.000910753 - Residual ratio : 0.000852104 - Slope : -0.0444966 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.9762 - Final Residual ratio : 0.0364784 - Residual ratio : 0.000986537 - Slope : -1.84699 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.3663 - Final Residual ratio : 0.0282501 - Residual ratio : 0.000930311 - Slope : -1.44467 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.7614 - Final Residual ratio : 0.00786276 - Residual ratio : 0.000616138 - Slope : -0.531396 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.61251 - Final Residual ratio : 0.0069786 - Residual ratio : 0.000810287 - Slope : -0.344221 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.83623 - Final Residual ratio : 0.00737805 - Residual ratio : 0.000941531 - Slope : -0.326202 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.66323 - Final Residual ratio : 0.00477896 - Residual ratio : 0.000717214 - Slope : -0.277436 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 341.01 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.024291; expected ratio = 0.0001obtained abs = 7.32281e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00727586; expected ratio = 0.001obtained abs = 2.72962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.5161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.40504 - Final Residual ratio : 0.00347496 - Residual ratio : 0.000642911 - Slope : -0.225065 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.38174 - Final Residual ratio : 0.00263249 - Residual ratio : 0.000600787 - Slope : -0.208529 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.65815 - Final Residual ratio : 0.00327667 - Residual ratio : 0.000895717 - Slope : -0.174042 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.16111 - Final Residual ratio : 0.00277287 - Residual ratio : 0.000877182 - Slope : -0.263195 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.79651 - Final Residual ratio : 0.00266648 - Residual ratio : 0.000953502 - Slope : -0.186256 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.46224 - Final Residual ratio : 0.00245782 - Residual ratio : 0.000998206 - Slope : -0.189214 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.7351 - Final Residual ratio : 0.02858 - Residual ratio : 0.000701607 - Slope : -2.03533 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.3707 - Final Residual ratio : 0.0259395 - Residual ratio : 0.000801327 - Slope : -1.70235 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.04362 - Final Residual ratio : 0.00713809 - Residual ratio : 0.000789295 - Slope : -0.410749 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36067 - Final Residual ratio : 0.002932 - Residual ratio : 0.000872444 - Slope : -0.13431 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805420e+05 Mflops = 340.03 -Solve time = 0.00 -Solve flops = 1.662000e+04 Mflops = 490.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0180329; expected ratio = 0.0001obtained abs = 5.4549e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00596698; expected ratio = 0.001obtained abs = 2.24406; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.5261 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.20494 - Final Residual ratio : 0.00243834 - Residual ratio : 0.000760807 - Slope : -0.1281 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.92848 - Final Residual ratio : 0.00290164 - Residual ratio : 0.000990835 - Slope : -0.127199 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.47618 - Final Residual ratio : 0.00161604 - Residual ratio : 0.000652632 - Slope : -0.117837 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.04948 - Final Residual ratio : 0.00153555 - Residual ratio : 0.000749241 - Slope : -0.0890411 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.71685 - Final Residual ratio : 0.00124848 - Residual ratio : 0.00072719 - Slope : -0.0714835 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.45042 - Final Residual ratio : 0.0012692 - Residual ratio : 0.000875061 - Slope : -0.0630063 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27577 - Final Residual ratio : 0.0011984 - Residual ratio : 0.000939354 - Slope : -0.055416 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5331 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18714 - Final Residual ratio : 0.000809145 - Residual ratio : 0.000681593 - Slope : -0.0564919 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.16504 - Final Residual ratio : 0.000838015 - Residual ratio : 0.000719301 - Slope : -0.0554383 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17451 - Final Residual ratio : 0.000998794 - Residual ratio : 0.00085039 - Slope : -0.0533415 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805420e+05 Mflops = 341.26 -Solve time = 0.00 -Solve flops = 1.662000e+04 Mflops = 490.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.011525; expected ratio = 0.0001obtained abs = 3.51753e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00501924; expected ratio = 0.001obtained abs = 1.89144; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.5361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15755 - Final Residual ratio : 0.000921667 - Residual ratio : 0.000796224 - Slope : -0.0550774 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12443 - Final Residual ratio : 0.000994504 - Residual ratio : 0.00088445 - Slope : -0.0802456 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07142 - Final Residual ratio : 0.00102575 - Residual ratio : 0.000957383 - Slope : -0.0465387 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00587 - Final Residual ratio : 0.00086883 - Residual ratio : 0.000863757 - Slope : -0.0436958 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.947691 - Final Residual ratio : 0.00083255 - Residual ratio : 0.000878503 - Slope : -0.0394524 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.886444 - Final Residual ratio : 0.000733316 - Residual ratio : 0.000827257 - Slope : -0.0354284 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.849513 - Final Residual ratio : 0.000700301 - Residual ratio : 0.000824356 - Slope : -0.0339525 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.82914 - Final Residual ratio : 0.000671623 - Residual ratio : 0.000810024 - Slope : -0.0331387 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.823671 - Final Residual ratio : 0.000681964 - Residual ratio : 0.000827957 - Slope : -0.0342912 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.83415 - Final Residual ratio : 0.000773299 - Residual ratio : 0.000927051 - Slope : -0.0396846 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 341.78 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 475.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0127145; expected ratio = 0.0001obtained abs = 3.91675e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00347824; expected ratio = 0.001obtained abs = 1.31269; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.5461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.836808 - Final Residual ratio : 0.000575001 - Residual ratio : 0.000687136 - Slope : -0.0398206 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.846457 - Final Residual ratio : 0.000486526 - Residual ratio : 0.000574779 - Slope : -0.0402843 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.850363 - Final Residual ratio : 0.000568158 - Residual ratio : 0.000668136 - Slope : -0.0404664 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.847187 - Final Residual ratio : 0.000775058 - Residual ratio : 0.000914861 - Slope : -0.0403053 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.844302 - Final Residual ratio : 0.000770751 - Residual ratio : 0.000912885 - Slope : -0.0383423 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.824049 - Final Residual ratio : 0.000817077 - Residual ratio : 0.000991539 - Slope : -0.0357927 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.81304 - Final Residual ratio : 0.000691212 - Residual ratio : 0.000850158 - Slope : -0.0338478 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.804213 - Final Residual ratio : 0.000752966 - Residual ratio : 0.000936277 - Slope : -0.0334775 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.798643 - Final Residual ratio : 0.000699068 - Residual ratio : 0.000875321 - Slope : -0.0332477 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.7766 - Final Residual ratio : 0.0114374 - Residual ratio : 0.000830205 - Slope : -0.625688 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817960e+05 Mflops = 341.63 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 478.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.018422; expected ratio = 0.0001obtained abs = 5.7659e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00500261; expected ratio = 0.001obtained abs = 1.89367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.5561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.7811 - Final Residual ratio : 0.016934 - Residual ratio : 0.000656836 - Slope : -1.07351 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.51583 - Final Residual ratio : 0.00626031 - Residual ratio : 0.00083295 - Slope : -0.300383 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.1457 - Final Residual ratio : 0.0049048 - Residual ratio : 0.000798088 - Slope : -0.236184 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.27364 - Final Residual ratio : 0.00369441 - Residual ratio : 0.000700544 - Slope : -0.20269 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.40555 - Final Residual ratio : 0.00301619 - Residual ratio : 0.000684635 - Slope : -0.169328 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.71734 - Final Residual ratio : 0.00335758 - Residual ratio : 0.000903222 - Slope : -0.148559 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.22031 - Final Residual ratio : 0.00250992 - Residual ratio : 0.000779404 - Slope : -0.139904 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84738 - Final Residual ratio : 0.00219375 - Residual ratio : 0.000770446 - Slope : -0.135485 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.527 - Final Residual ratio : 0.00247567 - Residual ratio : 0.000979685 - Slope : -0.120216 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.21785 - Final Residual ratio : 0.00178065 - Residual ratio : 0.000802873 - Slope : -0.10073 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822380e+05 Mflops = 345.24 -Solve time = 0.00 -Solve flops = 1.668400e+04 Mflops = 492.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0180456; expected ratio = 0.0001obtained abs = 5.73359e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00563108; expected ratio = 0.001obtained abs = 2.13524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.5661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.22626 - Final Residual ratio : 0.0071574 - Residual ratio : 0.000775763 - Slope : -0.368764 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.9401 - Final Residual ratio : 0.0217361 - Residual ratio : 0.000907938 - Slope : -0.996598 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.59912 - Final Residual ratio : 0.00553909 - Residual ratio : 0.000728913 - Slope : -0.303743 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.27661 - Final Residual ratio : 0.00266326 - Residual ratio : 0.000622751 - Slope : -0.158294 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.78501 - Final Residual ratio : 0.00369741 - Residual ratio : 0.000976855 - Slope : -0.145435 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11246 - Final Residual ratio : 0.0022169 - Residual ratio : 0.000712267 - Slope : -0.115194 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.41461 - Final Residual ratio : 0.00216814 - Residual ratio : 0.000897926 - Slope : -0.0927864 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83443 - Final Residual ratio : 0.00119769 - Residual ratio : 0.000652893 - Slope : -0.0797058 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41982 - Final Residual ratio : 0.00111868 - Residual ratio : 0.000787901 - Slope : -0.0675573 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1512 - Final Residual ratio : 0.000983853 - Residual ratio : 0.000854633 - Slope : -0.0479256 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822380e+05 Mflops = 336.72 -Solve time = 0.00 -Solve flops = 1.668400e+04 Mflops = 479.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0168139; expected ratio = 0.0001obtained abs = 5.39656e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00549457; expected ratio = 0.001obtained abs = 2.08934; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.5761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.91866 - Final Residual ratio : 0.000874643 - Residual ratio : 0.000952085 - Slope : -0.0382411 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.744627 - Final Residual ratio : 0.000502593 - Residual ratio : 0.000674959 - Slope : -0.029765 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.636593 - Final Residual ratio : 0.000590461 - Residual ratio : 0.000927533 - Slope : -0.0265001 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.61299 - Final Residual ratio : 0.000448618 - Residual ratio : 0.000731852 - Slope : -0.0245016 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.634341 - Final Residual ratio : 0.000529606 - Residual ratio : 0.000834891 - Slope : -0.0243773 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5811 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.694567 - Final Residual ratio : 0.000606692 - Residual ratio : 0.000873483 - Slope : -0.0266908 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.729436 - Final Residual ratio : 0.000561468 - Residual ratio : 0.000769729 - Slope : -0.0280336 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.738708 - Final Residual ratio : 0.00057069 - Residual ratio : 0.000772551 - Slope : -0.0295255 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.729048 - Final Residual ratio : 0.00059656 - Residual ratio : 0.000818273 - Slope : -0.0331114 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.690038 - Final Residual ratio : 0.000667257 - Residual ratio : 0.000966986 - Slope : -0.031335 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822380e+05 Mflops = 342.61 -Solve time = 0.00 -Solve flops = 1.668400e+04 Mflops = 492.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0168857; expected ratio = 0.0001obtained abs = 5.47842e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00450139; expected ratio = 0.001obtained abs = 1.71493; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.5861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.690663 - Final Residual ratio : 0.000553921 - Residual ratio : 0.000802014 - Slope : -0.0276044 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.682315 - Final Residual ratio : 0.000617089 - Residual ratio : 0.000904404 - Slope : -0.0272679 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.680756 - Final Residual ratio : 0.000632913 - Residual ratio : 0.000929721 - Slope : -0.0272049 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.95162 - Final Residual ratio : 0.00223143 - Residual ratio : 0.000755999 - Slope : -0.117976 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.30273 - Final Residual ratio : 0.00165315 - Residual ratio : 0.000717907 - Slope : -0.0920431 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53537 - Final Residual ratio : 0.00150903 - Residual ratio : 0.000982844 - Slope : -0.0852143 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.891314 - Final Residual ratio : 0.000774585 - Residual ratio : 0.000869038 - Slope : -0.0356216 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.79208 - Final Residual ratio : 0.000757698 - Residual ratio : 0.000956592 - Slope : -0.0329718 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.768718 - Final Residual ratio : 0.000577187 - Residual ratio : 0.000750844 - Slope : -0.0320059 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.74396 - Final Residual ratio : 0.000476843 - Residual ratio : 0.000640953 - Slope : -0.0323253 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.5951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 342.65 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 475.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0311295; expected ratio = 0.0001obtained abs = 1.02646e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00516168; expected ratio = 0.001obtained abs = 1.9707; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 343.27 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 488.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00948884; expected ratio = 0.0001obtained abs = 3.11664e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00202719; expected ratio = 0.001obtained abs = 0.774426; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.5961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.741624 - Final Residual ratio : 0.000295679 - Residual ratio : 0.000398692 - Slope : -0.0336968 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.730489 - Final Residual ratio : 0.000608353 - Residual ratio : 0.000832802 - Slope : -0.0347562 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.720682 - Final Residual ratio : 0.00045419 - Residual ratio : 0.000630223 - Slope : -0.0327376 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.5991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.713427 - Final Residual ratio : 0.000612181 - Residual ratio : 0.000858084 - Slope : -0.0324007 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.5991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.696592 - Final Residual ratio : 0.000426706 - Residual ratio : 0.000612562 - Slope : -0.0316439 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.711863 - Final Residual ratio : 0.000459099 - Residual ratio : 0.000644926 - Slope : -0.0323365 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.719515 - Final Residual ratio : 0.000556607 - Residual ratio : 0.000773587 - Slope : -0.0342361 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.728914 - Final Residual ratio : 0.000496399 - Residual ratio : 0.000681011 - Slope : -0.0346866 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.738131 - Final Residual ratio : 0.000471504 - Residual ratio : 0.000638781 - Slope : -0.0351266 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.730287 - Final Residual ratio : 0.000503718 - Residual ratio : 0.000689753 - Slope : -0.0347516 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 342.65 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 475.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0229636; expected ratio = 0.0001obtained abs = 7.65495e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0037309; expected ratio = 0.001obtained abs = 1.42743; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.749646 - Final Residual ratio : 0.000480535 - Residual ratio : 0.000641016 - Slope : -0.0356745 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.6071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.754135 - Final Residual ratio : 0.000478396 - Residual ratio : 0.000634364 - Slope : -0.0358884 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.755985 - Final Residual ratio : 0.000526705 - Residual ratio : 0.000696713 - Slope : -0.0359742 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.75624 - Final Residual ratio : 0.00059769 - Residual ratio : 0.000790345 - Slope : -0.035983 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.740026 - Final Residual ratio : 0.000541536 - Residual ratio : 0.00073178 - Slope : -0.0352136 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.753376 - Final Residual ratio : 0.000638346 - Residual ratio : 0.000847314 - Slope : -0.0358447 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.754274 - Final Residual ratio : 0.000642315 - Residual ratio : 0.000851567 - Slope : -0.0358872 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.7553 - Final Residual ratio : 0.000620952 - Residual ratio : 0.000822127 - Slope : -0.0359371 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.756719 - Final Residual ratio : 0.000591946 - Residual ratio : 0.000782253 - Slope : -0.0360061 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.742492 - Final Residual ratio : 0.000469437 - Residual ratio : 0.000632245 - Slope : -0.0353344 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.825460e+05 Mflops = 341.20 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 476.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0299812; expected ratio = 0.0001obtained abs = 1.01654e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00523999; expected ratio = 0.001obtained abs = 2.01139; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 344.51 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 478.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.021621; expected ratio = 0.0001obtained abs = 7.31515e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00337043; expected ratio = 0.001obtained abs = 1.29611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.758452 - Final Residual ratio : 0.000531734 - Residual ratio : 0.000701078 - Slope : -0.0360915 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.760911 - Final Residual ratio : 0.000540103 - Residual ratio : 0.000709812 - Slope : -0.0362081 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6181 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762528 - Final Residual ratio : 0.000548784 - Residual ratio : 0.000719691 - Slope : -0.0362847 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.763445 - Final Residual ratio : 0.000560038 - Residual ratio : 0.000733566 - Slope : -0.0363279 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.747318 - Final Residual ratio : 0.000500179 - Residual ratio : 0.000669299 - Slope : -0.0355627 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762017 - Final Residual ratio : 0.000539817 - Residual ratio : 0.000708405 - Slope : -0.0362608 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762525 - Final Residual ratio : 0.000531702 - Residual ratio : 0.000697292 - Slope : -0.0362854 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.76263 - Final Residual ratio : 0.000517358 - Residual ratio : 0.000678387 - Slope : -0.0362911 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762665 - Final Residual ratio : 0.000508849 - Residual ratio : 0.000667199 - Slope : -0.0362932 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.745615 - Final Residual ratio : 0.000437055 - Residual ratio : 0.000586167 - Slope : -0.0354847 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.825460e+05 Mflops = 344.42 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 476.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0258046; expected ratio = 0.0001obtained abs = 8.85334e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00529201; expected ratio = 0.001obtained abs = 2.04115; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.76139 - Final Residual ratio : 0.000498154 - Residual ratio : 0.000654268 - Slope : -0.036233 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762411 - Final Residual ratio : 0.000518821 - Residual ratio : 0.0006805 - Slope : -0.0362806 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.763105 - Final Residual ratio : 0.000530357 - Residual ratio : 0.000694998 - Slope : -0.0363131 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.763542 - Final Residual ratio : 0.000537862 - Residual ratio : 0.000704429 - Slope : -0.0363335 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.745482 - Final Residual ratio : 0.000485165 - Residual ratio : 0.000650807 - Slope : -0.035476 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762197 - Final Residual ratio : 0.000521215 - Residual ratio : 0.000683833 - Slope : -0.0362703 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762718 - Final Residual ratio : 0.000514229 - Residual ratio : 0.000674206 - Slope : -0.0362954 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762877 - Final Residual ratio : 0.000497352 - Residual ratio : 0.000651943 - Slope : -0.0363038 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762864 - Final Residual ratio : 0.00048481 - Residual ratio : 0.000635513 - Slope : -0.0363038 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.743351 - Final Residual ratio : 0.000425286 - Residual ratio : 0.00057212 - Slope : -0.0353774 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.825460e+05 Mflops = 343.80 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 489.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0326571; expected ratio = 0.0001obtained abs = 1.14174e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100415; expected ratio = 0.001obtained abs = 3.8965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804160e+05 Mflops = 341.63 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 487.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0844291; expected ratio = 0.0001obtained abs = 3.00547e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105875; expected ratio = 0.001obtained abs = 4.13672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 334.58 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0198434; expected ratio = 0.0001obtained abs = 7.07787e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00763523; expected ratio = 0.001obtained abs = 2.99631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.761251 - Final Residual ratio : 0.000468547 - Residual ratio : 0.000615496 - Slope : -0.0362277 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.761837 - Final Residual ratio : 0.00048351 - Residual ratio : 0.000634664 - Slope : -0.0362549 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.76219 - Final Residual ratio : 0.000495685 - Residual ratio : 0.000650343 - Slope : -0.0362712 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.7153 - Final Residual ratio : 0.0217574 - Residual ratio : 0.00084609 - Slope : -1.07056 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.41469 - Final Residual ratio : 0.0048515 - Residual ratio : 0.000756312 - Slope : -0.267076 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.25272 - Final Residual ratio : 0.00166355 - Residual ratio : 0.00073846 - Slope : -0.150071 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00258 - Final Residual ratio : 0.00180571 - Residual ratio : 0.000901692 - Slope : -0.0869902 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.20589 - Final Residual ratio : 0.00218813 - Residual ratio : 0.000991947 - Slope : -0.110185 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.29428 - Final Residual ratio : 0.00228505 - Residual ratio : 0.000995974 - Slope : -0.104182 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.18694 - Final Residual ratio : 0.00152783 - Residual ratio : 0.000698615 - Slope : -0.0993368 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 3 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 342.65 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 475.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0630055; expected ratio = 0.0001obtained abs = 2.17051e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0149134; expected ratio = 0.001obtained abs = 5.79317; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 341.52 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0479544; expected ratio = 0.0001obtained abs = 1.67052e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00767285; expected ratio = 0.001obtained abs = 2.97429; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 342.79 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 491.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0385963; expected ratio = 0.0001obtained abs = 1.38313e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100587; expected ratio = 0.001obtained abs = 3.92396; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 337.16 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0759997; expected ratio = 0.0001obtained abs = 2.7823e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.011573; expected ratio = 0.001obtained abs = 4.54994; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 342.13 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0444001; expected ratio = 0.0001obtained abs = 1.57581e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00956773; expected ratio = 0.001obtained abs = 3.74917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 343.89 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 492.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0736586; expected ratio = 0.0001obtained abs = 2.49087e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0180229; expected ratio = 0.001obtained abs = 6.96709; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.825460e+05 Mflops = 344.42 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.079271; expected ratio = 0.0001obtained abs = 2.80478e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0133937; expected ratio = 0.001obtained abs = 5.1989; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822820e+05 Mflops = 344.55 -Solve time = 0.00 -Solve flops = 1.669000e+04 Mflops = 476.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0972091; expected ratio = 0.0001obtained abs = 3.54001e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.013795; expected ratio = 0.001obtained abs = 5.40148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804160e+05 Mflops = 341.79 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 487.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0332707; expected ratio = 0.0001obtained abs = 1.23331e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0138337; expected ratio = 0.001obtained abs = 5.46692; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 343.27 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 475.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.124467; expected ratio = 0.0001obtained abs = 4.20116e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0263562; expected ratio = 0.001obtained abs = 10.2314; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 336.51 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 474.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0594015; expected ratio = 0.0001obtained abs = 2.05769e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116471; expected ratio = 0.001obtained abs = 4.50195; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822820e+05 Mflops = 343.93 -Solve time = 0.00 -Solve flops = 1.669000e+04 Mflops = 489.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0431492; expected ratio = 0.0001obtained abs = 1.52738e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115354; expected ratio = 0.001obtained abs = 4.4809; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 342.95 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.115748; expected ratio = 0.0001obtained abs = 4.30774e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0183708; expected ratio = 0.001obtained abs = 7.22457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 341.52 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0500786; expected ratio = 0.0001obtained abs = 1.80241e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0132931; expected ratio = 0.001obtained abs = 5.22428; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 344.04 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 488.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.130595; expected ratio = 0.0001obtained abs = 4.29332e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0292617; expected ratio = 0.001obtained abs = 11.2493; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812920e+05 Mflops = 343.45 -Solve time = 0.00 -Solve flops = 1.666600e+04 Mflops = 475.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.114196; expected ratio = 0.0001obtained abs = 4.06028e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0199052; expected ratio = 0.001obtained abs = 7.69893; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 341.96 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 474.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.11827; expected ratio = 0.0001obtained abs = 4.38106e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0193137; expected ratio = 0.001obtained abs = 7.56701; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 333.99 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 474.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0408788; expected ratio = 0.0001obtained abs = 1.53234e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.017426; expected ratio = 0.001obtained abs = 6.90008; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822380e+05 Mflops = 344.46 -Solve time = 0.00 -Solve flops = 1.668400e+04 Mflops = 492.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.173861; expected ratio = 0.0001obtained abs = 5.73394e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0352442; expected ratio = 0.001obtained abs = 13.6198; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.825460e+05 Mflops = 345.04 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 489.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0957824; expected ratio = 0.0001obtained abs = 3.34916e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0153353; expected ratio = 0.001obtained abs = 5.9196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.95599 - Final Residual ratio : 0.00190965 - Residual ratio : 0.000976307 - Slope : -0.0849601 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64853 - Final Residual ratio : 0.0012806 - Residual ratio : 0.000776814 - Slope : -0.0716194 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33637 - Final Residual ratio : 0.00107342 - Residual ratio : 0.000803235 - Slope : -0.0635855 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07225 - Final Residual ratio : 0.00105867 - Residual ratio : 0.00098733 - Slope : -0.0465736 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.872597 - Final Residual ratio : 0.000801294 - Residual ratio : 0.000918287 - Slope : -0.0348718 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.787313 - Final Residual ratio : 0.000575656 - Residual ratio : 0.000731166 - Slope : -0.0302591 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.749103 - Final Residual ratio : 0.000597109 - Residual ratio : 0.000797098 - Slope : -0.0299403 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6531 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 61.1937 - Final Residual ratio : 0.0530541 - Residual ratio : 0.000866987 - Slope : -2.54753 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.9806 - Final Residual ratio : 0.00958468 - Residual ratio : 0.00068557 - Slope : -0.517445 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.97057 - Final Residual ratio : 0.00568324 - Residual ratio : 0.00081532 - Slope : -0.497492 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 340.66 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 475.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.110575; expected ratio = 0.0001obtained abs = 3.69508e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0183438; expected ratio = 0.001obtained abs = 7.03537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 342.65 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 492.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0408172; expected ratio = 0.0001obtained abs = 1.39072e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01191; expected ratio = 0.001obtained abs = 4.56461; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 342.65 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 488.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0450972; expected ratio = 0.0001obtained abs = 1.48927e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115263; expected ratio = 0.001obtained abs = 4.38933; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814920e+05 Mflops = 342.43 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0492341; expected ratio = 0.0001obtained abs = 1.69512e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00899586; expected ratio = 0.001obtained abs = 3.43761; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814920e+05 Mflops = 341.21 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0328447; expected ratio = 0.0001obtained abs = 1.10044e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00655242; expected ratio = 0.001obtained abs = 2.49886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814920e+05 Mflops = 342.43 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0253147; expected ratio = 0.0001obtained abs = 8.6628e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00539645; expected ratio = 0.001obtained abs = 2.06208; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.13139 - Final Residual ratio : 0.0038196 - Residual ratio : 0.000744361 - Slope : -0.197214 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.63031 - Final Residual ratio : 0.00372441 - Residual ratio : 0.000804356 - Slope : -0.171355 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.07422 - Final Residual ratio : 0.00393585 - Residual ratio : 0.000966037 - Slope : -0.150751 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.41674 - Final Residual ratio : 0.00199662 - Residual ratio : 0.000584363 - Slope : -0.121955 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.754 - Final Residual ratio : 0.00262894 - Residual ratio : 0.000954589 - Slope : -0.101903 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.21239 - Final Residual ratio : 0.00212761 - Residual ratio : 0.00096168 - Slope : -0.08501 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.85616 - Final Residual ratio : 0.00126308 - Residual ratio : 0.000680482 - Slope : -0.074196 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.68689 - Final Residual ratio : 0.00144414 - Residual ratio : 0.000856094 - Slope : -0.0674178 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61837 - Final Residual ratio : 0.00115989 - Residual ratio : 0.000716704 - Slope : -0.0735094 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55126 - Final Residual ratio : 0.000999288 - Residual ratio : 0.00064418 - Slope : -0.0704662 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838580e+05 Mflops = 345.66 -Solve time = 0.00 -Solve flops = 1.676800e+04 Mflops = 478.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.126186; expected ratio = 0.0001obtained abs = 4.61569e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0240812; expected ratio = 0.001obtained abs = 9.30598; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846920e+05 Mflops = 349.26 -Solve time = 0.00 -Solve flops = 1.681400e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.16806; expected ratio = 0.0001obtained abs = 6.52711e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0259443; expected ratio = 0.001obtained abs = 10.1942; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 344.15 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0833666; expected ratio = 0.0001obtained abs = 3.18211e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0255546; expected ratio = 0.001obtained abs = 10.1202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814920e+05 Mflops = 345.07 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 491.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.295375; expected ratio = 0.0001obtained abs = 9.17362e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0559354; expected ratio = 0.001obtained abs = 21.2751; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845960e+05 Mflops = 349.71 -Solve time = 0.00 -Solve flops = 1.680800e+04 Mflops = 492.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.200672; expected ratio = 0.0001obtained abs = 7.34862e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0343389; expected ratio = 0.001obtained abs = 13.1958; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846920e+05 Mflops = 349.26 -Solve time = 0.00 -Solve flops = 1.681400e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.123993; expected ratio = 0.0001obtained abs = 4.72793e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.026329; expected ratio = 0.001obtained abs = 10.2946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 342.57 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 477.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0775676; expected ratio = 0.0001obtained abs = 2.99529e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0239618; expected ratio = 0.001obtained abs = 9.50817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 344.51 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 492.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.204875; expected ratio = 0.0001obtained abs = 6.84207e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0383578; expected ratio = 0.001obtained abs = 14.8551; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.825460e+05 Mflops = 346.92 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0833176; expected ratio = 0.0001obtained abs = 2.88134e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0173221; expected ratio = 0.001obtained abs = 6.66149; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818080e+05 Mflops = 344.89 -Solve time = 0.00 -Solve flops = 1.666400e+04 Mflops = 492.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0697303; expected ratio = 0.0001obtained abs = 2.50845e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0168227; expected ratio = 0.001obtained abs = 6.51479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 343.35 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 487.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.160858; expected ratio = 0.0001obtained abs = 6.22974e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0250058; expected ratio = 0.001obtained abs = 9.84603; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 343.53 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0939804; expected ratio = 0.0001obtained abs = 3.46749e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0221981; expected ratio = 0.001obtained abs = 8.74893; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814920e+05 Mflops = 336.68 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.219116; expected ratio = 0.0001obtained abs = 6.94901e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0442251; expected ratio = 0.001obtained abs = 16.8585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845960e+05 Mflops = 349.71 -Solve time = 0.00 -Solve flops = 1.680800e+04 Mflops = 492.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.177771; expected ratio = 0.0001obtained abs = 6.48882e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0301615; expected ratio = 0.001obtained abs = 11.6145; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846920e+05 Mflops = 349.10 -Solve time = 0.00 -Solve flops = 1.681400e+04 Mflops = 496.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.147158; expected ratio = 0.0001obtained abs = 5.66557e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0262292; expected ratio = 0.001obtained abs = 10.2796; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 344.15 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0717802; expected ratio = 0.0001obtained abs = 2.75233e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0229477; expected ratio = 0.001obtained abs = 9.09176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 345.91 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 488.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.250481; expected ratio = 0.0001obtained abs = 8.04779e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0471075; expected ratio = 0.001obtained abs = 18.0637; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845960e+05 Mflops = 349.55 -Solve time = 0.00 -Solve flops = 1.680800e+04 Mflops = 479.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.152977; expected ratio = 0.0001obtained abs = 5.47707e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0254947; expected ratio = 0.001obtained abs = 9.7887; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843320e+05 Mflops = 347.79 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 492.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0742231; expected ratio = 0.0001obtained abs = 2.76877e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0204558; expected ratio = 0.001obtained abs = 7.96298; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 335.82 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.111461; expected ratio = 0.0001obtained abs = 4.2819e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0209221; expected ratio = 0.001obtained abs = 8.25776; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48128 - Final Residual ratio : 0.00132004 - Residual ratio : 0.00089115 - Slope : -0.0616649 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6671 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37425 - Final Residual ratio : 0.000983897 - Residual ratio : 0.000715954 - Slope : -0.0549305 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26268 - Final Residual ratio : 0.00103145 - Residual ratio : 0.000816872 - Slope : -0.0573475 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15569 - Final Residual ratio : 0.00101236 - Residual ratio : 0.000875979 - Slope : -0.0461871 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05552 - Final Residual ratio : 0.00068193 - Residual ratio : 0.000646061 - Slope : -0.0405707 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.996882 - Final Residual ratio : 0.000647339 - Residual ratio : 0.000649364 - Slope : -0.0383167 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.948782 - Final Residual ratio : 0.000927305 - Residual ratio : 0.000977364 - Slope : -0.0379142 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.919397 - Final Residual ratio : 0.000917986 - Residual ratio : 0.000998465 - Slope : -0.03827 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.905182 - Final Residual ratio : 0.000751538 - Residual ratio : 0.000830262 - Slope : -0.0411105 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.890573 - Final Residual ratio : 0.000765951 - Residual ratio : 0.000860065 - Slope : -0.0404458 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 339.68 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 474.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.102495; expected ratio = 0.0001obtained abs = 3.69665e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0172013; expected ratio = 0.001obtained abs = 6.74651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 340.90 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0692038; expected ratio = 0.0001obtained abs = 2.40619e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0165206; expected ratio = 0.001obtained abs = 6.40006; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818400e+05 Mflops = 343.09 -Solve time = 0.00 -Solve flops = 1.666400e+04 Mflops = 377.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0789337; expected ratio = 0.0001obtained abs = 2.91661e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0140121; expected ratio = 0.001obtained abs = 5.46865; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 342.11 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 487.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.097277; expected ratio = 0.0001obtained abs = 3.67581e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0137463; expected ratio = 0.001obtained abs = 5.4133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804160e+05 Mflops = 340.40 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 490.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0311399; expected ratio = 0.0001obtained abs = 1.1576e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00855345; expected ratio = 0.001obtained abs = 3.37962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 341.52 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0839721; expected ratio = 0.0001obtained abs = 2.93106e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0176537; expected ratio = 0.001obtained abs = 6.88667; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 342.33 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0674346; expected ratio = 0.0001obtained abs = 2.48375e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0113967; expected ratio = 0.001obtained abs = 4.46838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 342.18 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 491.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0385508; expected ratio = 0.0001obtained abs = 1.40856e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0063386; expected ratio = 0.001obtained abs = 2.48971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804160e+05 Mflops = 340.40 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 487.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0182993; expected ratio = 0.0001obtained abs = 6.77768e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00635111; expected ratio = 0.001obtained abs = 2.5031; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.898084 - Final Residual ratio : 0.00058895 - Residual ratio : 0.000655785 - Slope : -0.0390215 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.894386 - Final Residual ratio : 0.000700899 - Residual ratio : 0.000783664 - Slope : -0.0388559 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.88601 - Final Residual ratio : 0.000828184 - Residual ratio : 0.000934735 - Slope : -0.0402355 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.872538 - Final Residual ratio : 0.0005249 - Residual ratio : 0.000601579 - Slope : -0.0396369 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.4231 - Final Residual ratio : 0.0172697 - Residual ratio : 0.000991196 - Slope : -0.725244 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.54753 - Final Residual ratio : 0.00918351 - Residual ratio : 0.000961873 - Slope : -0.381534 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.69451 - Final Residual ratio : 0.00345099 - Residual ratio : 0.000934085 - Slope : -0.230691 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.13375 - Final Residual ratio : 0.00169688 - Residual ratio : 0.000795257 - Slope : -0.0789649 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.07543 - Final Residual ratio : 0.00138775 - Residual ratio : 0.000668655 - Slope : -0.0768163 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.29356 - Final Residual ratio : 0.00174613 - Residual ratio : 0.00076132 - Slope : -0.0881466 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 9 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 340.90 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.063935; expected ratio = 0.0001obtained abs = 2.26384e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0178388; expected ratio = 0.001obtained abs = 6.9551; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00048399 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 343.89 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 488.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0551711; expected ratio = 0.0001obtained abs = 1.93479e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0156393; expected ratio = 0.001obtained abs = 6.0331; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845960e+05 Mflops = 346.89 -Solve time = 0.00 -Solve flops = 1.680800e+04 Mflops = 496.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0582364; expected ratio = 0.0001obtained abs = 2.08114e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0135262; expected ratio = 0.001obtained abs = 5.19267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845960e+05 Mflops = 348.29 -Solve time = 0.00 -Solve flops = 1.680800e+04 Mflops = 492.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.082145; expected ratio = 0.0001obtained abs = 3.13681e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0207239; expected ratio = 0.001obtained abs = 8.06296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843320e+05 Mflops = 348.42 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 479.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0989143; expected ratio = 0.0001obtained abs = 3.80207e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0153345; expected ratio = 0.001obtained abs = 6.02322; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 342.13 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0519093; expected ratio = 0.0001obtained abs = 1.95698e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0151891; expected ratio = 0.001obtained abs = 5.97406; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819340e+05 Mflops = 344.51 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 475.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.176066; expected ratio = 0.0001obtained abs = 5.87553e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0355542; expected ratio = 0.001obtained abs = 13.6325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841540e+05 Mflops = 346.83 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 478.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.116043; expected ratio = 0.0001obtained abs = 4.19461e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0190267; expected ratio = 0.001obtained abs = 7.28426; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838580e+05 Mflops = 346.90 -Solve time = 0.00 -Solve flops = 1.676800e+04 Mflops = 495.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0803685; expected ratio = 0.0001obtained abs = 3.07494e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0235355; expected ratio = 0.001obtained abs = 9.1549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 349.79 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.137086; expected ratio = 0.0001obtained abs = 5.38475e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0200156; expected ratio = 0.001obtained abs = 7.88812; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 342.13 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0959664; expected ratio = 0.0001obtained abs = 3.55883e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0213759; expected ratio = 0.001obtained abs = 8.39855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814920e+05 Mflops = 343.83 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.182804; expected ratio = 0.0001obtained abs = 5.99217e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0397733; expected ratio = 0.001obtained abs = 15.167; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841540e+05 Mflops = 346.83 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 492.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.14355; expected ratio = 0.0001obtained abs = 5.27264e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0222399; expected ratio = 0.001obtained abs = 8.52269; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842180e+05 Mflops = 347.58 -Solve time = 0.00 -Solve flops = 1.678800e+04 Mflops = 495.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0767611; expected ratio = 0.0001obtained abs = 2.96116e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0239578; expected ratio = 0.001obtained abs = 9.33754; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834380e+05 Mflops = 346.11 -Solve time = 0.00 -Solve flops = 1.677600e+04 Mflops = 478.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.1261; expected ratio = 0.0001obtained abs = 4.93043e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018165; expected ratio = 0.001obtained abs = 7.1629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 342.13 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.10375; expected ratio = 0.0001obtained abs = 3.7956e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0212875; expected ratio = 0.001obtained abs = 8.34326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814920e+05 Mflops = 343.67 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 491.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.146622; expected ratio = 0.0001obtained abs = 4.87787e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0341238; expected ratio = 0.001obtained abs = 13.0314; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841540e+05 Mflops = 346.83 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 492.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.124247; expected ratio = 0.0001obtained abs = 4.55408e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0192054; expected ratio = 0.001obtained abs = 7.3644; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838580e+05 Mflops = 339.27 -Solve time = 0.00 -Solve flops = 1.676800e+04 Mflops = 478.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0736086; expected ratio = 0.0001obtained abs = 2.83306e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0232352; expected ratio = 0.001obtained abs = 9.05464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818620e+05 Mflops = 348.30 -Solve time = 0.00 -Solve flops = 1.671800e+04 Mflops = 477.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.124175; expected ratio = 0.0001obtained abs = 4.8421e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.017456; expected ratio = 0.001obtained abs = 6.8796; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.40541 - Final Residual ratio : 0.00146684 - Residual ratio : 0.000609809 - Slope : -0.089035 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.3508 - Final Residual ratio : 0.00190438 - Residual ratio : 0.000810096 - Slope : -0.0869963 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.16378 - Final Residual ratio : 0.00216264 - Residual ratio : 0.000999472 - Slope : -0.0864647 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.90419 - Final Residual ratio : 0.001298 - Residual ratio : 0.000681651 - Slope : -0.0827346 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.6314 - Final Residual ratio : 0.00149584 - Residual ratio : 0.000916908 - Slope : -0.0651961 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.383 - Final Residual ratio : 0.00136924 - Residual ratio : 0.000990048 - Slope : -0.0552654 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18856 - Final Residual ratio : 0.0009994 - Residual ratio : 0.000840849 - Slope : -0.0475024 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05173 - Final Residual ratio : 0.000808701 - Residual ratio : 0.000768928 - Slope : -0.0420367 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.960329 - Final Residual ratio : 0.000933308 - Residual ratio : 0.000971863 - Slope : -0.0417128 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.896978 - Final Residual ratio : 0.000395501 - Residual ratio : 0.000440927 - Slope : -0.0407537 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.6951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.6951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 340.29 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0566504; expected ratio = 0.0001obtained abs = 2.15712e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00971009; expected ratio = 0.001obtained abs = 3.83325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 333.99 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0882447; expected ratio = 0.0001obtained abs = 3.15605e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161095; expected ratio = 0.001obtained abs = 6.288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 341.34 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 491.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0847837; expected ratio = 0.0001obtained abs = 3.24604e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0135125; expected ratio = 0.001obtained abs = 5.31044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 341.56 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0649833; expected ratio = 0.0001obtained abs = 2.43934e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00828518; expected ratio = 0.001obtained abs = 3.26235; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804160e+05 Mflops = 341.02 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 487.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0157641; expected ratio = 0.0001obtained abs = 5.92586e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00516451; expected ratio = 0.001obtained abs = 2.03612; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.6961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.852977 - Final Residual ratio : 0.000644331 - Residual ratio : 0.000755391 - Slope : -0.037058 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.817603 - Final Residual ratio : 0.000777048 - Residual ratio : 0.000950398 - Slope : -0.0340344 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.791961 - Final Residual ratio : 0.000564464 - Residual ratio : 0.000712743 - Slope : -0.0329748 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.6991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.775046 - Final Residual ratio : 0.000616229 - Residual ratio : 0.000795087 - Slope : -0.0336709 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.6991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762005 - Final Residual ratio : 0.000592675 - Residual ratio : 0.000777783 - Slope : -0.0346097 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.761483 - Final Residual ratio : 0.000271357 - Residual ratio : 0.000356353 - Slope : -0.0346005 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.759949 - Final Residual ratio : 0.000326699 - Residual ratio : 0.000429896 - Slope : -0.0345283 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.759549 - Final Residual ratio : 0.000383406 - Residual ratio : 0.000504781 - Slope : -0.0345075 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.758533 - Final Residual ratio : 0.00041991 - Residual ratio : 0.000553581 - Slope : -0.0344597 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.755112 - Final Residual ratio : 0.000330828 - Residual ratio : 0.000438118 - Slope : -0.0343083 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 341.56 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 475.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0386303; expected ratio = 0.0001obtained abs = 1.42829e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00625735; expected ratio = 0.001obtained abs = 2.45913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 341.34 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 487.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0427987; expected ratio = 0.0001obtained abs = 1.63601e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00754769; expected ratio = 0.001obtained abs = 2.97788; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 343.35 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 474.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0319346; expected ratio = 0.0001obtained abs = 1.19584e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00515368; expected ratio = 0.001obtained abs = 2.03168; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 337.76 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0194369; expected ratio = 0.0001obtained abs = 7.27331e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00351259; expected ratio = 0.001obtained abs = 1.38264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.752888 - Final Residual ratio : 0.000354445 - Residual ratio : 0.00047078 - Slope : -0.0342061 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.749425 - Final Residual ratio : 0.000315796 - Residual ratio : 0.000421385 - Slope : -0.0340504 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.7081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.746117 - Final Residual ratio : 0.0007208 - Residual ratio : 0.000966069 - Slope : -0.035495 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.743351 - Final Residual ratio : 0.000225481 - Residual ratio : 0.000303331 - Slope : -0.0337784 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.73942 - Final Residual ratio : 0.000713199 - Residual ratio : 0.000964538 - Slope : -0.0351765 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.737831 - Final Residual ratio : 0.000666933 - Residual ratio : 0.000903909 - Slope : -0.0351031 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.736135 - Final Residual ratio : 0.000256788 - Residual ratio : 0.000348833 - Slope : -0.033449 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.734736 - Final Residual ratio : 0.000264069 - Residual ratio : 0.000359407 - Slope : -0.0333851 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.734005 - Final Residual ratio : 0.000253449 - Residual ratio : 0.000345297 - Slope : -0.0333523 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.73247 - Final Residual ratio : 0.000208229 - Residual ratio : 0.000284283 - Slope : -0.0332846 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 337.54 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 487.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0321269; expected ratio = 0.0001obtained abs = 1.23097e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00535729; expected ratio = 0.001obtained abs = 2.11181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 487.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0359255; expected ratio = 0.0001obtained abs = 1.39954e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00657595; expected ratio = 0.001obtained abs = 2.5972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 341.07 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 489.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0144482; expected ratio = 0.0001obtained abs = 5.5771e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00321208; expected ratio = 0.001obtained abs = 1.26746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.732439 - Final Residual ratio : 0.000241042 - Residual ratio : 0.000329096 - Slope : -0.0332817 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.732038 - Final Residual ratio : 0.000279862 - Residual ratio : 0.000382306 - Slope : -0.0332617 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.731528 - Final Residual ratio : 0.000323602 - Residual ratio : 0.000442365 - Slope : -0.0332366 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.730822 - Final Residual ratio : 0.000303801 - Residual ratio : 0.000415698 - Slope : -0.0332054 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.72866 - Final Residual ratio : 0.000253125 - Residual ratio : 0.000347384 - Slope : -0.0331094 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.728466 - Final Residual ratio : 0.000310197 - Residual ratio : 0.000425822 - Slope : -0.033098 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.727682 - Final Residual ratio : 0.000330563 - Residual ratio : 0.000454268 - Slope : -0.0330614 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.72705 - Final Residual ratio : 0.000338535 - Residual ratio : 0.000465629 - Slope : -0.0330323 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.726535 - Final Residual ratio : 0.000338931 - Residual ratio : 0.000466503 - Slope : -0.0330089 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.724458 - Final Residual ratio : 0.000279454 - Residual ratio : 0.000385742 - Slope : -0.0329172 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 3 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 346.82 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 476.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0202083; expected ratio = 0.0001obtained abs = 7.90665e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0042664; expected ratio = 0.001obtained abs = 1.6826; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.725262 - Final Residual ratio : 0.000313773 - Residual ratio : 0.000432635 - Slope : -0.0329522 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.725055 - Final Residual ratio : 0.000312792 - Residual ratio : 0.000431404 - Slope : -0.0329428 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.724869 - Final Residual ratio : 0.000308879 - Residual ratio : 0.000426117 - Slope : -0.0329346 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.72459 - Final Residual ratio : 0.000305576 - Residual ratio : 0.000421722 - Slope : -0.032922 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.722138 - Final Residual ratio : 0.000257026 - Residual ratio : 0.000355923 - Slope : -0.0328128 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.723255 - Final Residual ratio : 0.00030332 - Residual ratio : 0.000419381 - Slope : -0.0328614 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.722871 - Final Residual ratio : 0.000317387 - Residual ratio : 0.000439064 - Slope : -0.0328434 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.722572 - Final Residual ratio : 0.000323927 - Residual ratio : 0.000448297 - Slope : -0.0328295 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.722294 - Final Residual ratio : 0.000325329 - Residual ratio : 0.00045041 - Slope : -0.0328168 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.719502 - Final Residual ratio : 0.000275455 - Residual ratio : 0.000382841 - Slope : -0.0326921 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 341.98 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 494.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0304474; expected ratio = 0.0001obtained abs = 1.22083e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00575913; expected ratio = 0.001obtained abs = 2.27851; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 346.98 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 489.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00686358; expected ratio = 0.0001obtained abs = 2.74009e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00323435; expected ratio = 0.001obtained abs = 1.28106; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.721308 - Final Residual ratio : 0.000310615 - Residual ratio : 0.000430628 - Slope : -0.0327726 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.721124 - Final Residual ratio : 0.000312957 - Residual ratio : 0.000433985 - Slope : -0.0327641 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.720996 - Final Residual ratio : 0.000309907 - Residual ratio : 0.000429832 - Slope : -0.0327585 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.72081 - Final Residual ratio : 0.000306859 - Residual ratio : 0.000425714 - Slope : -0.0327501 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.717316 - Final Residual ratio : 0.000260898 - Residual ratio : 0.000363714 - Slope : -0.0325934 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.719797 - Final Residual ratio : 0.000298585 - Residual ratio : 0.000414818 - Slope : -0.0327045 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.719522 - Final Residual ratio : 0.000307228 - Residual ratio : 0.000426989 - Slope : -0.0326916 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.719342 - Final Residual ratio : 0.000310106 - Residual ratio : 0.000431097 - Slope : -0.0326833 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.719165 - Final Residual ratio : 0.000310811 - Residual ratio : 0.000432184 - Slope : -0.0326752 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.715228 - Final Residual ratio : 0.000267475 - Residual ratio : 0.000373971 - Slope : -0.0324982 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 345.56 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 489.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0179041; expected ratio = 0.0001obtained abs = 7.13971e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00527086; expected ratio = 0.001obtained abs = 2.08406; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.718361 - Final Residual ratio : 0.000301003 - Residual ratio : 0.000419014 - Slope : -0.0326391 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.718192 - Final Residual ratio : 0.000304931 - Residual ratio : 0.000424581 - Slope : -0.0326312 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.718103 - Final Residual ratio : 0.000303479 - Residual ratio : 0.000422612 - Slope : -0.0326273 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.71797 - Final Residual ratio : 0.000301254 - Residual ratio : 0.000419591 - Slope : -0.0326213 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 60.9635 - Final Residual ratio : 0.0466329 - Residual ratio : 0.000764932 - Slope : -2.64856 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9278 - Final Residual ratio : 0.0155718 - Residual ratio : 0.00078141 - Slope : -0.765854 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.32945 - Final Residual ratio : 0.00784322 - Residual ratio : 0.000840694 - Slope : -0.717047 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.3556 - Final Residual ratio : 0.00402769 - Residual ratio : 0.000752053 - Slope : -0.20583 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.52629 - Final Residual ratio : 0.00315481 - Residual ratio : 0.000696998 - Slope : -0.173967 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.97836 - Final Residual ratio : 0.00337623 - Residual ratio : 0.000848649 - Slope : -0.159 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 346.35 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 476.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0227668; expected ratio = 0.0001obtained abs = 9.03729e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00427961; expected ratio = 0.001obtained abs = 1.69323; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.34495 - Final Residual ratio : 0.00296694 - Residual ratio : 0.000886991 - Slope : -0.133679 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.67883 - Final Residual ratio : 0.00183378 - Residual ratio : 0.000684547 - Slope : -0.102961 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11344 - Final Residual ratio : 0.0016096 - Residual ratio : 0.0007616 - Slope : -0.0812244 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75472 - Final Residual ratio : 0.00151784 - Residual ratio : 0.000865004 - Slope : -0.076226 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.60822 - Final Residual ratio : 0.00155558 - Residual ratio : 0.00096727 - Slope : -0.12359 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56495 - Final Residual ratio : 0.00105672 - Residual ratio : 0.000675244 - Slope : -0.0601498 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52559 - Final Residual ratio : 0.00136649 - Residual ratio : 0.000895711 - Slope : -0.060969 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4484 - Final Residual ratio : 0.00129224 - Residual ratio : 0.000892186 - Slope : -0.0602962 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33619 - Final Residual ratio : 0.00129555 - Residual ratio : 0.000969583 - Slope : -0.0606771 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22024 - Final Residual ratio : 0.00101709 - Residual ratio : 0.000833513 - Slope : -0.0530098 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 341.98 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 490.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0292744; expected ratio = 0.0001obtained abs = 1.18921e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00672894; expected ratio = 0.001obtained abs = 2.66695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 347.62 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 476.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0153267; expected ratio = 0.0001obtained abs = 6.15192e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00409818; expected ratio = 0.001obtained abs = 1.62335; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10353 - Final Residual ratio : 0.000774212 - Residual ratio : 0.00070158 - Slope : -0.0424136 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01263 - Final Residual ratio : 0.000917832 - Residual ratio : 0.000906386 - Slope : -0.0389119 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.944436 - Final Residual ratio : 0.000784891 - Residual ratio : 0.000831069 - Slope : -0.0362943 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.896639 - Final Residual ratio : 0.000867385 - Residual ratio : 0.000967374 - Slope : -0.0358309 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.870118 - Final Residual ratio : 0.000864012 - Residual ratio : 0.000992982 - Slope : -0.0377936 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.850838 - Final Residual ratio : 0.000641409 - Residual ratio : 0.000753856 - Slope : -0.0369651 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7721 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.844991 - Final Residual ratio : 0.000736973 - Residual ratio : 0.000872167 - Slope : -0.0351772 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.842938 - Final Residual ratio : 0.000656025 - Residual ratio : 0.00077826 - Slope : -0.0336913 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.839414 - Final Residual ratio : 0.000566683 - Residual ratio : 0.000675094 - Slope : -0.0335539 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.835217 - Final Residual ratio : 0.000682127 - Residual ratio : 0.000816706 - Slope : -0.0347723 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 342.74 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 477.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0321056; expected ratio = 0.0001obtained abs = 1.32665e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00690186; expected ratio = 0.001obtained abs = 2.74085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 345.21 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 490.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0171129; expected ratio = 0.0001obtained abs = 6.97081e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00355362; expected ratio = 0.001obtained abs = 1.41041; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.819277 - Final Residual ratio : 0.000769686 - Residual ratio : 0.00093947 - Slope : -0.0372049 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.805057 - Final Residual ratio : 0.000404784 - Residual ratio : 0.000502801 - Slope : -0.0365751 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.790091 - Final Residual ratio : 0.000767101 - Residual ratio : 0.000970903 - Slope : -0.0375868 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.776481 - Final Residual ratio : 0.000209335 - Residual ratio : 0.000269595 - Slope : -0.0352851 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.767427 - Final Residual ratio : 0.000297664 - Residual ratio : 0.000387873 - Slope : -0.0348695 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.755205 - Final Residual ratio : 0.00030765 - Residual ratio : 0.000407373 - Slope : -0.0343135 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.00686 - Final Residual ratio : 0.00638699 - Residual ratio : 0.000911534 - Slope : -0.538498 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.7905 - Final Residual ratio : 0.0214873 - Residual ratio : 0.00094282 - Slope : -1.03496 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.22353 - Final Residual ratio : 0.00543462 - Residual ratio : 0.000873237 - Slope : -0.239158 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.32847 - Final Residual ratio : 0.00382219 - Residual ratio : 0.000883035 - Slope : -0.160172 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 340.00 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 477.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0272562; expected ratio = 0.0001obtained abs = 1.13696e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0055213; expected ratio = 0.001obtained abs = 2.19536; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 345.21 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 477.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0072458; expected ratio = 0.0001obtained abs = 3.0143e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00275975; expected ratio = 0.001obtained abs = 1.09865; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79315 - Final Residual ratio : 0.00230402 - Residual ratio : 0.000607416 - Slope : -0.135387 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.16004 - Final Residual ratio : 0.00256064 - Residual ratio : 0.000810318 - Slope : -0.116944 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.65974 - Final Residual ratio : 0.00250784 - Residual ratio : 0.00094289 - Slope : -0.102201 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.32544 - Final Residual ratio : 0.00196652 - Residual ratio : 0.000845655 - Slope : -0.0968114 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.10383 - Final Residual ratio : 0.00159827 - Residual ratio : 0.000759693 - Slope : -0.0914014 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.88634 - Final Residual ratio : 0.00159544 - Residual ratio : 0.000845788 - Slope : -0.0785308 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67964 - Final Residual ratio : 0.00135767 - Residual ratio : 0.00080831 - Slope : -0.0671315 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47422 - Final Residual ratio : 0.00127839 - Residual ratio : 0.000867164 - Slope : -0.0589178 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7941 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.28851 - Final Residual ratio : 0.000912612 - Residual ratio : 0.000708266 - Slope : -0.0585274 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.16194 - Final Residual ratio : 0.00115388 - Residual ratio : 0.00099306 - Slope : -0.0483662 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.7951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.7951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 335.83 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 477.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0191624; expected ratio = 0.0001obtained abs = 8.11323e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00433849; expected ratio = 0.001obtained abs = 1.72836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.7961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03737 - Final Residual ratio : 0.000739212 - Residual ratio : 0.000712583 - Slope : -0.0398705 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.97314 - Final Residual ratio : 0.000580786 - Residual ratio : 0.000596816 - Slope : -0.0374061 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.932953 - Final Residual ratio : 0.000628095 - Residual ratio : 0.000673233 - Slope : -0.0358587 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.7991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.903217 - Final Residual ratio : 0.000793662 - Residual ratio : 0.000878706 - Slope : -0.0360969 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.7991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.897609 - Final Residual ratio : 0.00082671 - Residual ratio : 0.000921013 - Slope : -0.0389905 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.849044 - Final Residual ratio : 0.000334443 - Residual ratio : 0.000393906 - Slope : -0.0385777 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.824445 - Final Residual ratio : 0.000688586 - Residual ratio : 0.000835212 - Slope : -0.0374435 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.801425 - Final Residual ratio : 0.000699502 - Residual ratio : 0.000872823 - Slope : -0.0348142 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.780114 - Final Residual ratio : 0.000728396 - Residual ratio : 0.000933705 - Slope : -0.0338863 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.781355 - Final Residual ratio : 0.000645945 - Residual ratio : 0.000826699 - Slope : -0.0339439 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 344.78 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 493.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0471005; expected ratio = 0.0001obtained abs = 2.04509e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00676992; expected ratio = 0.001obtained abs = 2.70653; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 347.72 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0189949; expected ratio = 0.0001obtained abs = 8.29144e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00505131; expected ratio = 0.001obtained abs = 2.02624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.741508 - Final Residual ratio : 0.000484932 - Residual ratio : 0.00065398 - Slope : -0.0322184 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.726379 - Final Residual ratio : 0.000502867 - Residual ratio : 0.000692292 - Slope : -0.0329944 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.713229 - Final Residual ratio : 0.0003943 - Residual ratio : 0.000552837 - Slope : -0.0324016 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.8091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.701833 - Final Residual ratio : 0.000420391 - Residual ratio : 0.00059899 - Slope : -0.0318824 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.711139 - Final Residual ratio : 0.000482779 - Residual ratio : 0.000678881 - Slope : -0.0323026 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.682511 - Final Residual ratio : 0.000355098 - Residual ratio : 0.000520282 - Slope : -0.0310071 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8121 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.676588 - Final Residual ratio : 0.000287017 - Residual ratio : 0.000424212 - Slope : -0.030741 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.671674 - Final Residual ratio : 0.000225065 - Residual ratio : 0.000335081 - Slope : -0.0305204 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.66741 - Final Residual ratio : 0.000278147 - Residual ratio : 0.000416756 - Slope : -0.0303242 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8151 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.680197 - Final Residual ratio : 0.000278696 - Residual ratio : 0.000409728 - Slope : -0.0309054 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 345.21 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 477.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0173858; expected ratio = 0.0001obtained abs = 7.53783e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00296972; expected ratio = 0.001obtained abs = 1.18963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.657899 - Final Residual ratio : 0.000372405 - Residual ratio : 0.000566052 - Slope : -0.0298876 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.654782 - Final Residual ratio : 0.000394282 - Residual ratio : 0.000602159 - Slope : -0.0297449 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.65147 - Final Residual ratio : 0.00035397 - Residual ratio : 0.000543341 - Slope : -0.0295962 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.648002 - Final Residual ratio : 0.000368815 - Residual ratio : 0.000569158 - Slope : -0.0294379 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.658916 - Final Residual ratio : 0.000335927 - Residual ratio : 0.000509818 - Slope : -0.0299355 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8211 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.63923 - Final Residual ratio : 0.000334933 - Residual ratio : 0.000523963 - Slope : -0.0290407 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.636614 - Final Residual ratio : 0.000308465 - Residual ratio : 0.000484541 - Slope : -0.028923 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.634164 - Final Residual ratio : 0.00028361 - Residual ratio : 0.000447218 - Slope : -0.0288127 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.631984 - Final Residual ratio : 0.000277022 - Residual ratio : 0.000438337 - Slope : -0.0287139 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.6424 - Final Residual ratio : 0.000266783 - Residual ratio : 0.000415292 - Slope : -0.0291879 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 1 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 347.52 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 491.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.106412; expected ratio = 0.0001obtained abs = 4.87258e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106817; expected ratio = 0.001obtained abs = 4.30413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 347.88 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0505775; expected ratio = 0.0001obtained abs = 2.30117e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00631173; expected ratio = 0.001obtained abs = 2.55328; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 349.15 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 477.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.096465; expected ratio = 0.0001obtained abs = 4.17245e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00989449; expected ratio = 0.001obtained abs = 3.97643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.824320e+05 Mflops = 349.55 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 491.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0817898; expected ratio = 0.0001obtained abs = 3.64207e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00514731; expected ratio = 0.001obtained abs = 2.06844; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 350.22 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 491.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0541566; expected ratio = 0.0001obtained abs = 2.50262e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00890157; expected ratio = 0.001obtained abs = 3.60079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 347.62 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 476.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0487561; expected ratio = 0.0001obtained abs = 2.18026e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00561356; expected ratio = 0.001obtained abs = 2.26586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 349.15 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 477.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0540919; expected ratio = 0.0001obtained abs = 2.38387e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00427365; expected ratio = 0.001obtained abs = 1.71983; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438213 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 350.22 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 495.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0729477; expected ratio = 0.0001obtained abs = 3.31708e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00460716; expected ratio = 0.001obtained abs = 1.85922; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 348.99 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 477.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0709133; expected ratio = 0.0001obtained abs = 3.17277e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00248961; expected ratio = 0.001obtained abs = 1.00523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000481129 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 347.72 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0451359; expected ratio = 0.0001obtained abs = 1.96919e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00592846; expected ratio = 0.001obtained abs = 2.3836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.824320e+05 Mflops = 348.12 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 491.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0797749; expected ratio = 0.0001obtained abs = 3.59967e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00497667; expected ratio = 0.001obtained abs = 2.00483; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 348.36 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 494.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0303607; expected ratio = 0.0001obtained abs = 1.37807e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00382657; expected ratio = 0.001obtained abs = 1.54594; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 347.88 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.075847; expected ratio = 0.0001obtained abs = 3.34209e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0045608; expected ratio = 0.001obtained abs = 1.83772; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 348.52 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0171455; expected ratio = 0.0001obtained abs = 7.54161e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00299835; expected ratio = 0.001obtained abs = 1.20552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.626629 - Final Residual ratio : 0.000284501 - Residual ratio : 0.000454019 - Slope : -0.0284702 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.625663 - Final Residual ratio : 0.000280945 - Residual ratio : 0.000449036 - Slope : -0.0284265 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.624587 - Final Residual ratio : 0.000300575 - Residual ratio : 0.000481239 - Slope : -0.0283766 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.623388 - Final Residual ratio : 0.000319914 - Residual ratio : 0.000513186 - Slope : -0.0283213 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.632169 - Final Residual ratio : 0.000312065 - Residual ratio : 0.000493641 - Slope : -0.0287208 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.618922 - Final Residual ratio : 0.000326117 - Residual ratio : 0.000526911 - Slope : -0.028118 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.618006 - Final Residual ratio : 0.000319269 - Residual ratio : 0.000516611 - Slope : -0.0280767 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.616995 - Final Residual ratio : 0.000314544 - Residual ratio : 0.0005098 - Slope : -0.0280309 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.615999 - Final Residual ratio : 0.000310962 - Residual ratio : 0.00050481 - Slope : -0.0279858 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.623377 - Final Residual ratio : 0.000300085 - Residual ratio : 0.000481387 - Slope : -0.0283217 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 14 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 347.52 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0871091; expected ratio = 0.0001obtained abs = 4.04148e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00975776; expected ratio = 0.001obtained abs = 3.94548; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817660e+05 Mflops = 348.12 -Solve time = 0.00 -Solve flops = 1.671200e+04 Mflops = 480.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0250466; expected ratio = 0.0001obtained abs = 1.16491e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00581281; expected ratio = 0.001obtained abs = 2.35907; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 347.46 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 479.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0455581; expected ratio = 0.0001obtained abs = 2.05075e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00667363; expected ratio = 0.001obtained abs = 2.69662; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 349.42 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 495.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0224945; expected ratio = 0.0001obtained abs = 1.02678e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00318727; expected ratio = 0.001obtained abs = 1.28797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 349.42 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 495.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0249218; expected ratio = 0.0001obtained abs = 1.15875e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00531867; expected ratio = 0.001obtained abs = 2.15772; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 339.10 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 476.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0408933; expected ratio = 0.0001obtained abs = 1.84812e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00559536; expected ratio = 0.001obtained abs = 2.26303; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 349.42 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 491.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0240516; expected ratio = 0.0001obtained abs = 1.09466e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0029123; expected ratio = 0.001obtained abs = 1.17672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 349.42 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 495.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0235287; expected ratio = 0.0001obtained abs = 1.09024e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00461357; expected ratio = 0.001obtained abs = 1.87038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796440e+05 Mflops = 346.27 -Solve time = 0.00 -Solve flops = 1.660200e+04 Mflops = 486.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0307057; expected ratio = 0.0001obtained abs = 1.39598e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00356896; expected ratio = 0.001obtained abs = 1.44449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817660e+05 Mflops = 342.34 -Solve time = 0.00 -Solve flops = 1.671200e+04 Mflops = 493.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0171285; expected ratio = 0.0001obtained abs = 7.77341e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00249927; expected ratio = 0.001obtained abs = 1.00987; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.61263 - Final Residual ratio : 0.000308117 - Residual ratio : 0.000502941 - Slope : -0.0278328 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.612364 - Final Residual ratio : 0.000299938 - Residual ratio : 0.000489803 - Slope : -0.0278211 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.612 - Final Residual ratio : 0.000294995 - Residual ratio : 0.000482018 - Slope : -0.0278048 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.61155 - Final Residual ratio : 0.00029697 - Residual ratio : 0.000485601 - Slope : -0.0277842 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.617812 - Final Residual ratio : 0.000295089 - Residual ratio : 0.000477635 - Slope : -0.028069 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.608917 - Final Residual ratio : 0.000308566 - Residual ratio : 0.000506746 - Slope : -0.027664 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.608718 - Final Residual ratio : 0.000310396 - Residual ratio : 0.000509917 - Slope : -0.0276549 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.608381 - Final Residual ratio : 0.000312476 - Residual ratio : 0.000513619 - Slope : -0.0276395 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.3743 - Final Residual ratio : 0.0367371 - Residual ratio : 0.000909913 - Slope : -1.68073 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.2295 - Final Residual ratio : 0.0207763 - Residual ratio : 0.000894394 - Slope : -1.00907 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831380e+05 Mflops = 349.63 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.064274; expected ratio = 0.0001obtained abs = 3.08713e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115511; expected ratio = 0.001obtained abs = 4.69395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 349.58 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0160854; expected ratio = 0.0001obtained abs = 7.70298e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00619807; expected ratio = 0.001obtained abs = 2.52721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9201 - Final Residual ratio : 0.0117725 - Residual ratio : 0.000987618 - Slope : -0.626752 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.85081 - Final Residual ratio : 0.0048456 - Residual ratio : 0.000998925 - Slope : -0.17948 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79277 - Final Residual ratio : 0.00288319 - Residual ratio : 0.000760181 - Slope : -0.135353 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.39659 - Final Residual ratio : 0.00287725 - Residual ratio : 0.000847101 - Slope : -0.130527 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.77923 - Final Residual ratio : 0.00209746 - Residual ratio : 0.00075469 - Slope : -0.0991833 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.07517 - Final Residual ratio : 0.00161866 - Residual ratio : 0.000780015 - Slope : -0.0740554 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4678 - Final Residual ratio : 0.00143247 - Residual ratio : 0.000975931 - Slope : -0.0586547 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09813 - Final Residual ratio : 0.00100477 - Residual ratio : 0.000914987 - Slope : -0.0457135 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8541 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.961052 - Final Residual ratio : 0.000612627 - Residual ratio : 0.000637455 - Slope : -0.03694 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.907785 - Final Residual ratio : 0.000606805 - Residual ratio : 0.000668445 - Slope : -0.0335992 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 347.36 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 481.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0403468; expected ratio = 0.0001obtained abs = 1.88501e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00521996; expected ratio = 0.001obtained abs = 2.12285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 349.42 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0159816; expected ratio = 0.0001obtained abs = 7.56407e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00265261; expected ratio = 0.001obtained abs = 1.07979; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.835402 - Final Residual ratio : 0.000544706 - Residual ratio : 0.000652029 - Slope : -0.0309206 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.732745 - Final Residual ratio : 0.000507179 - Residual ratio : 0.000692163 - Slope : -0.028163 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.642217 - Final Residual ratio : 0.000423247 - Residual ratio : 0.00065904 - Slope : -0.0291725 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.607382 - Final Residual ratio : 0.000372398 - Residual ratio : 0.00061312 - Slope : -0.0233465 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.633163 - Final Residual ratio : 0.000464331 - Residual ratio : 0.000733352 - Slope : -0.0234333 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.66843 - Final Residual ratio : 0.000565438 - Residual ratio : 0.00084592 - Slope : -0.0247357 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.699296 - Final Residual ratio : 0.000685289 - Residual ratio : 0.00097997 - Slope : -0.0268696 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.710471 - Final Residual ratio : 0.000516469 - Residual ratio : 0.000726938 - Slope : -0.0273059 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.705188 - Final Residual ratio : 0.000605775 - Residual ratio : 0.000859026 - Slope : -0.0320265 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.695741 - Final Residual ratio : 0.00062146 - Residual ratio : 0.000893235 - Slope : -0.0267354 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831380e+05 Mflops = 342.92 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0273885; expected ratio = 0.0001obtained abs = 1.32196e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00553212; expected ratio = 0.001obtained abs = 2.2598; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 350.86 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0138379; expected ratio = 0.0001obtained abs = 6.66368e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00289578; expected ratio = 0.001obtained abs = 1.18433; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.675656 - Final Residual ratio : 0.000460836 - Residual ratio : 0.000682057 - Slope : -0.0250072 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.663315 - Final Residual ratio : 0.000470129 - Residual ratio : 0.000708757 - Slope : -0.0245498 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.655671 - Final Residual ratio : 0.000459009 - Residual ratio : 0.00070006 - Slope : -0.0242671 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.652746 - Final Residual ratio : 0.00058925 - Residual ratio : 0.000902725 - Slope : -0.0283546 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.655224 - Final Residual ratio : 0.000486816 - Residual ratio : 0.000742976 - Slope : -0.0251822 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.65798 - Final Residual ratio : 0.00060436 - Residual ratio : 0.000918508 - Slope : -0.0285815 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.2424 - Final Residual ratio : 0.0210215 - Residual ratio : 0.000904449 - Slope : -1.16107 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.79 - Final Residual ratio : 0.015182 - Residual ratio : 0.0008534 - Slope : -0.846418 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.98214 - Final Residual ratio : 0.00521691 - Residual ratio : 0.000747179 - Slope : -0.332235 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.7934 - Final Residual ratio : 0.020591 - Residual ratio : 0.000990267 - Slope : -1.59791 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 2 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 346.11 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 465.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0214959; expected ratio = 0.0001obtained abs = 1.02439e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00318759; expected ratio = 0.001obtained abs = 1.30159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831380e+05 Mflops = 348.20 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0279426; expected ratio = 0.0001obtained abs = 1.36103e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00651923; expected ratio = 0.001obtained abs = 2.67307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827780e+05 Mflops = 348.15 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0143277; expected ratio = 0.0001obtained abs = 6.95861e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0046959; expected ratio = 0.001obtained abs = 1.92951; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.0421 - Final Residual ratio : 0.0225684 - Residual ratio : 0.000938706 - Slope : -1.00081 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.2656 - Final Residual ratio : 0.00809209 - Residual ratio : 0.000788273 - Slope : -0.394519 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.7447 - Final Residual ratio : 0.0187949 - Residual ratio : 0.000653857 - Slope : -1.3679 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.78177 - Final Residual ratio : 0.00852696 - Residual ratio : 0.000970984 - Slope : -0.337433 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.09117 - Final Residual ratio : 0.00263948 - Residual ratio : 0.000853878 - Slope : -0.123541 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8811 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77598 - Final Residual ratio : 0.00143842 - Residual ratio : 0.000809932 - Slope : -0.0682515 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8821 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84442 - Final Residual ratio : 0.00147511 - Residual ratio : 0.000799772 - Slope : -0.0801279 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.91549 - Final Residual ratio : 0.00173392 - Residual ratio : 0.000905209 - Slope : -0.0765501 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8433 - Final Residual ratio : 0.0018413 - Residual ratio : 0.000998917 - Slope : -0.0736583 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67719 - Final Residual ratio : 0.0016321 - Residual ratio : 0.00097312 - Slope : -0.0881871 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 3 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831380e+05 Mflops = 350.27 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0332666; expected ratio = 0.0001obtained abs = 1.6057e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00730002; expected ratio = 0.001obtained abs = 2.98598; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822580e+05 Mflops = 350.50 -Solve time = 0.00 -Solve flops = 1.674600e+04 Mflops = 491.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0544117; expected ratio = 0.0001obtained abs = 2.74675e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0127817; expected ratio = 0.001obtained abs = 5.2647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818980e+05 Mflops = 349.81 -Solve time = 0.00 -Solve flops = 1.672600e+04 Mflops = 490.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0299188; expected ratio = 0.0001obtained abs = 1.53337e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105459; expected ratio = 0.001obtained abs = 4.37299; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 347.46 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 493.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.177444; expected ratio = 0.0001obtained abs = 8.20998e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0261356; expected ratio = 0.001obtained abs = 10.6539; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822580e+05 Mflops = 351.15 -Solve time = 0.00 -Solve flops = 1.674600e+04 Mflops = 494.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.146038; expected ratio = 0.0001obtained abs = 7.28733e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0206861; expected ratio = 0.001obtained abs = 8.45528; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822580e+05 Mflops = 350.50 -Solve time = 0.00 -Solve flops = 1.674600e+04 Mflops = 491.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.146532; expected ratio = 0.0001obtained abs = 8.24442e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0378373; expected ratio = 0.001obtained abs = 15.8778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 347.20 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.245192; expected ratio = 0.0001obtained abs = 1.17193e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0414344; expected ratio = 0.001obtained abs = 17.0475; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847280e+05 Mflops = 350.59 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 479.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.188355; expected ratio = 0.0001obtained abs = 8.58331e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0405318; expected ratio = 0.001obtained abs = 16.2292; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858420e+05 Mflops = 345.97 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 498.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.302998; expected ratio = 0.0001obtained abs = 1.81032e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.082224; expected ratio = 0.001obtained abs = 34.7318; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806340e+05 Mflops = 348.18 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.298361; expected ratio = 0.0001obtained abs = 1.46518e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0814373; expected ratio = 0.001obtained abs = 33.7508; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.830100e+05 Mflops = 346.55 -Solve time = 0.00 -Solve flops = 1.672400e+04 Mflops = 477.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.444765; expected ratio = 0.0001obtained abs = 1.70917e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0957977; expected ratio = 0.001obtained abs = 37.44; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859800e+05 Mflops = 352.17 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 481.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.682972; expected ratio = 0.0001obtained abs = 5.99779e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189139; expected ratio = 0.001obtained abs = 83.8692; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.782580e+05 Mflops = 346.95 -Solve time = 0.00 -Solve flops = 1.653400e+04 Mflops = 484.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.709577; expected ratio = 0.0001obtained abs = 4.17163e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134818; expected ratio = 0.001obtained abs = 58.7413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800760e+05 Mflops = 341.76 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 486.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.82752; expected ratio = 0.0001obtained abs = 3.28969e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129506; expected ratio = 0.001obtained abs = 52.5582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835340e+05 Mflops = 346.91 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 478.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.305242; expected ratio = 0.0001obtained abs = 1.39636e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0711901; expected ratio = 0.001obtained abs = 28.2704; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812160e+05 Mflops = 347.86 -Solve time = 0.00 -Solve flops = 1.668600e+04 Mflops = 489.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.442126; expected ratio = 0.0001obtained abs = 2.50204e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0808687; expected ratio = 0.001obtained abs = 33.6041; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 338.58 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 489.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.359157; expected ratio = 0.0001obtained abs = 2.33217e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0924015; expected ratio = 0.001obtained abs = 39.5422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 345.90 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.396234; expected ratio = 0.0001obtained abs = 2.10977e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0625052; expected ratio = 0.001obtained abs = 26.8664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816840e+05 Mflops = 349.40 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 479.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.566921; expected ratio = 0.0001obtained abs = 2.11385e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125178; expected ratio = 0.001obtained abs = 49.5312; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826720e+05 Mflops = 344.66 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 477.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.43722; expected ratio = 0.0001obtained abs = 2.60504e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108461; expected ratio = 0.001obtained abs = 45.4035; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.3545 - Final Residual ratio : 0.0192729 - Residual ratio : 0.000825234 - Slope : -0.9723 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.7049 - Final Residual ratio : 0.0175709 - Residual ratio : 0.000657964 - Slope : -1.11197 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.7648 - Final Residual ratio : 0.00994225 - Residual ratio : 0.000559661 - Slope : -0.845468 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8891 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.01324 - Final Residual ratio : 0.00665738 - Residual ratio : 0.000949258 - Slope : -0.538968 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8901 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.86006 - Final Residual ratio : 0.00237735 - Residual ratio : 0.000831225 - Slope : -0.109911 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.52065 - Final Residual ratio : 0.00239104 - Residual ratio : 0.000948581 - Slope : -0.104927 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.36858 - Final Residual ratio : 0.00192532 - Residual ratio : 0.00081286 - Slope : -0.107575 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.10902 - Final Residual ratio : 0.00154301 - Residual ratio : 0.000731621 - Slope : -0.0878116 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.79869 - Final Residual ratio : 0.00176868 - Residual ratio : 0.000983318 - Slope : -0.0781268 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48378 - Final Residual ratio : 0.00109654 - Residual ratio : 0.000739016 - Slope : -0.0673949 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.8951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.8951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809820e+05 Mflops = 345.36 -Solve time = 0.00 -Solve flops = 1.667400e+04 Mflops = 492.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.259833; expected ratio = 0.0001obtained abs = 1.4206e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0870152; expected ratio = 0.001obtained abs = 36.5342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812460e+05 Mflops = 347.28 -Solve time = 0.00 -Solve flops = 1.668800e+04 Mflops = 489.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.641834; expected ratio = 0.0001obtained abs = 2.4538e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11577; expected ratio = 0.001obtained abs = 45.1407; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 351.54 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 499.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.446136; expected ratio = 0.0001obtained abs = 2.70654e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0999843; expected ratio = 0.001obtained abs = 41.2894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 345.90 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.537597; expected ratio = 0.0001obtained abs = 4.56526e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140547; expected ratio = 0.001obtained abs = 63.7025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812500e+05 Mflops = 343.99 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 488.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.00568; expected ratio = 0.0001obtained abs = 4.85734e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119833; expected ratio = 0.001obtained abs = 52.176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 342.13 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.687286; expected ratio = 0.0001obtained abs = 2.33472e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.161403; expected ratio = 0.001obtained abs = 62.5757; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834740e+05 Mflops = 347.58 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 478.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.502357; expected ratio = 0.0001obtained abs = 2.79703e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.089082; expected ratio = 0.001obtained abs = 36.0264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.820960e+05 Mflops = 348.91 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.179316; expected ratio = 0.0001obtained abs = 1.07571e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0578715; expected ratio = 0.001obtained abs = 24.3022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809000e+05 Mflops = 347.25 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 488.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.313075; expected ratio = 0.0001obtained abs = 1.55396e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0405558; expected ratio = 0.001obtained abs = 16.7953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843680e+05 Mflops = 348.49 -Solve time = 0.00 -Solve flops = 1.680200e+04 Mflops = 482.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.315827; expected ratio = 0.0001obtained abs = 1.37062e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0553515; expected ratio = 0.001obtained abs = 22.1123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811380e+05 Mflops = 348.35 -Solve time = 0.00 -Solve flops = 1.668200e+04 Mflops = 489.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.366056; expected ratio = 0.0001obtained abs = 2.26451e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0937709; expected ratio = 0.001obtained abs = 39.5968; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813420e+05 Mflops = 348.10 -Solve time = 0.00 -Solve flops = 1.669400e+04 Mflops = 489.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.339564; expected ratio = 0.0001obtained abs = 1.72799e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0873915; expected ratio = 0.001obtained abs = 36.4326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.790280e+05 Mflops = 346.20 -Solve time = 0.00 -Solve flops = 1.657200e+04 Mflops = 486.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.467202; expected ratio = 0.0001obtained abs = 1.86381e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100378; expected ratio = 0.001obtained abs = 39.229; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 352.17 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 499.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.395226; expected ratio = 0.0001obtained abs = 2.33636e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0910196; expected ratio = 0.001obtained abs = 37.5487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 333.47 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.433655; expected ratio = 0.0001obtained abs = 3.08757e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104847; expected ratio = 0.001obtained abs = 45.6635; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 343.56 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 491.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.575873; expected ratio = 0.0001obtained abs = 2.95388e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0740617; expected ratio = 0.001obtained abs = 31.9884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808500e+05 Mflops = 342.46 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 488.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.643158; expected ratio = 0.0001obtained abs = 2.33311e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130844; expected ratio = 0.001obtained abs = 51.5325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834740e+05 Mflops = 348.05 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 492.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.464694; expected ratio = 0.0001obtained abs = 2.52643e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0735883; expected ratio = 0.001obtained abs = 29.7746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818980e+05 Mflops = 349.17 -Solve time = 0.00 -Solve flops = 1.672600e+04 Mflops = 490.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.121868; expected ratio = 0.0001obtained abs = 6.88205e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0426419; expected ratio = 0.001obtained abs = 17.712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813420e+05 Mflops = 348.74 -Solve time = 0.00 -Solve flops = 1.669400e+04 Mflops = 489.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.185364; expected ratio = 0.0001obtained abs = 1.01699e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0274166; expected ratio = 0.001obtained abs = 11.4588; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.8961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24729 - Final Residual ratio : 0.00088965 - Residual ratio : 0.000713269 - Slope : -0.0566544 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07723 - Final Residual ratio : 0.000959378 - Residual ratio : 0.0008906 - Slope : -0.0448445 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.980295 - Final Residual ratio : 0.000902796 - Residual ratio : 0.000920943 - Slope : -0.0391757 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.8991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.93506 - Final Residual ratio : 0.000877916 - Residual ratio : 0.000938887 - Slope : -0.0373673 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.8991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9001 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.891434 - Final Residual ratio : 0.000761569 - Residual ratio : 0.000854318 - Slope : -0.0371114 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.893382 - Final Residual ratio : 0.000750932 - Residual ratio : 0.000840549 - Slope : -0.03881 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.874092 - Final Residual ratio : 0.000427682 - Residual ratio : 0.000489287 - Slope : -0.0379854 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.850415 - Final Residual ratio : 0.000472506 - Residual ratio : 0.000555618 - Slope : -0.036954 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.825696 - Final Residual ratio : 0.000611949 - Residual ratio : 0.000741131 - Slope : -0.0358732 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.786184 - Final Residual ratio : 0.000702258 - Residual ratio : 0.000893249 - Slope : -0.0341514 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 342.49 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 478.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.333902; expected ratio = 0.0001obtained abs = 1.49855e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0619383; expected ratio = 0.001obtained abs = 24.9572; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858420e+05 Mflops = 348.76 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 494.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.326339; expected ratio = 0.0001obtained abs = 1.88508e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0764958; expected ratio = 0.001obtained abs = 31.9995; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809000e+05 Mflops = 345.83 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 488.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.262452; expected ratio = 0.0001obtained abs = 1.43721e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0700411; expected ratio = 0.001obtained abs = 29.4613; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808240e+05 Mflops = 346.47 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.532793; expected ratio = 0.0001obtained abs = 2.11123e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0988163; expected ratio = 0.001obtained abs = 38.9604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 350.91 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 496.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.364172; expected ratio = 0.0001obtained abs = 2.02499e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0859071; expected ratio = 0.001obtained abs = 35.3305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 338.58 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 489.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.480719; expected ratio = 0.0001obtained abs = 3.71896e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121371; expected ratio = 0.001obtained abs = 53.5973; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813880e+05 Mflops = 342.39 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 475.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.753486; expected ratio = 0.0001obtained abs = 3.74781e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0946122; expected ratio = 0.001obtained abs = 41.0264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808500e+05 Mflops = 341.22 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 488.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.645273; expected ratio = 0.0001obtained abs = 2.29575e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144609; expected ratio = 0.001obtained abs = 56.682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834740e+05 Mflops = 344.78 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 495.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.475174; expected ratio = 0.0001obtained abs = 2.57331e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0787673; expected ratio = 0.001obtained abs = 31.8413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 349.98 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.12176; expected ratio = 0.0001obtained abs = 6.56668e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0355741; expected ratio = 0.001obtained abs = 14.6447; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.820960e+05 Mflops = 348.27 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 494.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.176385; expected ratio = 0.0001obtained abs = 1.06493e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0533244; expected ratio = 0.001obtained abs = 22.659; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 344.93 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 474.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.365697; expected ratio = 0.0001obtained abs = 1.76994e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0564889; expected ratio = 0.001obtained abs = 23.5647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 345.93 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.196586; expected ratio = 0.0001obtained abs = 9.51613e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.051208; expected ratio = 0.001obtained abs = 20.9716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847280e+05 Mflops = 346.67 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 493.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.338548; expected ratio = 0.0001obtained abs = 1.43037e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0787319; expected ratio = 0.001obtained abs = 31.0026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 352.17 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 482.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.585214; expected ratio = 0.0001obtained abs = 4.71526e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16974; expected ratio = 0.001obtained abs = 74.2778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.767660e+05 Mflops = 341.19 -Solve time = 0.00 -Solve flops = 1.645000e+04 Mflops = 485.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.516531; expected ratio = 0.0001obtained abs = 2.97779e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.126128; expected ratio = 0.001obtained abs = 55.0028; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806880e+05 Mflops = 341.53 -Solve time = 0.00 -Solve flops = 1.663200e+04 Mflops = 487.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.699653; expected ratio = 0.0001obtained abs = 2.73758e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.13112; expected ratio = 0.001obtained abs = 52.4855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.840900e+05 Mflops = 346.09 -Solve time = 0.00 -Solve flops = 1.681400e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.398246; expected ratio = 0.0001obtained abs = 2.11992e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.060811; expected ratio = 0.001obtained abs = 24.8129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831140e+05 Mflops = 345.50 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 478.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.377135; expected ratio = 0.0001obtained abs = 1.89712e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.02925; expected ratio = 0.001obtained abs = 11.9022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814560e+05 Mflops = 345.63 -Solve time = 0.00 -Solve flops = 1.670000e+04 Mflops = 489.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.287167; expected ratio = 0.0001obtained abs = 1.86777e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0930517; expected ratio = 0.001obtained abs = 40.1923; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.780342 - Final Residual ratio : 0.000559184 - Residual ratio : 0.000716589 - Slope : -0.0339036 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.76552 - Final Residual ratio : 0.00072839 - Residual ratio : 0.000951497 - Slope : -0.0347633 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.754363 - Final Residual ratio : 0.000754231 - Residual ratio : 0.000999825 - Slope : -0.0342549 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.745895 - Final Residual ratio : 0.000394397 - Residual ratio : 0.000528757 - Slope : -0.032413 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 1.9101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.723383 - Final Residual ratio : 0.000492907 - Residual ratio : 0.000681392 - Slope : -0.03143 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.732555 - Final Residual ratio : 0.000612261 - Residual ratio : 0.000835788 - Slope : -0.0318236 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.730212 - Final Residual ratio : 0.000618523 - Residual ratio : 0.000847046 - Slope : -0.0317214 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.728186 - Final Residual ratio : 0.000642599 - Residual ratio : 0.000882466 - Slope : -0.0316323 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.725926 - Final Residual ratio : 0.000558504 - Residual ratio : 0.000769368 - Slope : -0.0315377 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.704845 - Final Residual ratio : 0.000500039 - Residual ratio : 0.000709431 - Slope : -0.0306237 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 336.69 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.26093; expected ratio = 0.0001obtained abs = 1.49941e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0749215; expected ratio = 0.001obtained abs = 32.7687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 341.70 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.597882; expected ratio = 0.0001obtained abs = 2.33505e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134358; expected ratio = 0.001obtained abs = 53.5395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847280e+05 Mflops = 347.76 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 483.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.30404; expected ratio = 0.0001obtained abs = 1.52304e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0515588; expected ratio = 0.001obtained abs = 20.4286; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 352.81 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 499.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.40328; expected ratio = 0.0001obtained abs = 2.89696e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113884; expected ratio = 0.001obtained abs = 48.7097; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.793600e+05 Mflops = 344.93 -Solve time = 0.00 -Solve flops = 1.658600e+04 Mflops = 486.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.292237; expected ratio = 0.0001obtained abs = 2.11456e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.083597; expected ratio = 0.001obtained abs = 37.1746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.793020e+05 Mflops = 344.82 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 473.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.822702; expected ratio = 0.0001obtained abs = 3.75623e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110549; expected ratio = 0.001obtained abs = 46.3902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 344.00 -Solve time = 0.00 -Solve flops = 1.672400e+04 Mflops = 493.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.392012; expected ratio = 0.0001obtained abs = 1.68666e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0884957; expected ratio = 0.001obtained abs = 35.0396; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819480e+05 Mflops = 347.99 -Solve time = 0.00 -Solve flops = 1.672600e+04 Mflops = 490.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.51959; expected ratio = 0.0001obtained abs = 3.48914e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11109; expected ratio = 0.001obtained abs = 47.1586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.799260e+05 Mflops = 346.65 -Solve time = 0.00 -Solve flops = 1.662400e+04 Mflops = 487.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.44167; expected ratio = 0.0001obtained abs = 3.15498e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0906399; expected ratio = 0.001obtained abs = 40.0655; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801720e+05 Mflops = 345.86 -Solve time = 0.00 -Solve flops = 1.663400e+04 Mflops = 487.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.699576; expected ratio = 0.0001obtained abs = 3.70186e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0847918; expected ratio = 0.001obtained abs = 36.9833; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.783920e+05 Mflops = 343.70 -Solve time = 0.00 -Solve flops = 1.653600e+04 Mflops = 485.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.665517; expected ratio = 0.0001obtained abs = 2.47835e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16211; expected ratio = 0.001obtained abs = 63.7752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 350.61 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.529779; expected ratio = 0.0001obtained abs = 3.38953e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122816; expected ratio = 0.001obtained abs = 51.3331; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 345.11 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 489.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.337163; expected ratio = 0.0001obtained abs = 2.2088e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0980612; expected ratio = 0.001obtained abs = 42.0624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809780e+05 Mflops = 346.14 -Solve time = 0.00 -Solve flops = 1.666600e+04 Mflops = 416.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.338409; expected ratio = 0.0001obtained abs = 1.93702e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0595729; expected ratio = 0.001obtained abs = 25.697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 347.46 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 493.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.51695; expected ratio = 0.0001obtained abs = 2.13041e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119672; expected ratio = 0.001obtained abs = 48.3077; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822580e+05 Mflops = 348.58 -Solve time = 0.00 -Solve flops = 1.674600e+04 Mflops = 491.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.544286; expected ratio = 0.0001obtained abs = 4.17466e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.147998; expected ratio = 0.001obtained abs = 64.6871; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 343.09 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 474.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.573784; expected ratio = 0.0001obtained abs = 3.00612e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122185; expected ratio = 0.001obtained abs = 53.1585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815140e+05 Mflops = 348.43 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 493.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.527878; expected ratio = 0.0001obtained abs = 2.10938e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.167573; expected ratio = 0.001obtained abs = 65.5348; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 351.54 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 482.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.44482; expected ratio = 0.0001obtained abs = 2.76913e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101989; expected ratio = 0.001obtained abs = 42.3185; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 337.36 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.444803; expected ratio = 0.0001obtained abs = 3.44211e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117022; expected ratio = 0.001obtained abs = 51.7125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.717214 - Final Residual ratio : 0.000489189 - Residual ratio : 0.000682068 - Slope : -0.0311619 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.714424 - Final Residual ratio : 0.000456184 - Residual ratio : 0.000638534 - Slope : -0.0310421 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.711382 - Final Residual ratio : 0.000433005 - Residual ratio : 0.000608682 - Slope : -0.0309108 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.708289 - Final Residual ratio : 0.00042097 - Residual ratio : 0.000594348 - Slope : -0.0307769 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.685336 - Final Residual ratio : 0.000404142 - Residual ratio : 0.000589698 - Slope : -0.0297797 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.700445 - Final Residual ratio : 0.00044389 - Residual ratio : 0.000633726 - Slope : -0.0304348 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.699385 - Final Residual ratio : 0.000480221 - Residual ratio : 0.000686634 - Slope : -0.0303871 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.698715 - Final Residual ratio : 0.000488599 - Residual ratio : 0.000699283 - Slope : -0.0303577 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.698152 - Final Residual ratio : 0.000517761 - Residual ratio : 0.000741617 - Slope : -0.0303319 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.675912 - Final Residual ratio : 0.000521961 - Residual ratio : 0.000772232 - Slope : -0.0293648 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801720e+05 Mflops = 346.49 -Solve time = 0.00 -Solve flops = 1.663400e+04 Mflops = 474.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.670213; expected ratio = 0.0001obtained abs = 3.64667e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0930978; expected ratio = 0.001obtained abs = 40.634; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796340e+05 Mflops = 346.09 -Solve time = 0.00 -Solve flops = 1.660200e+04 Mflops = 486.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.589465; expected ratio = 0.0001obtained abs = 2.30601e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.149757; expected ratio = 0.001obtained abs = 58.9858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826720e+05 Mflops = 346.53 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 373.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.571419; expected ratio = 0.0001obtained abs = 4.13706e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.13361; expected ratio = 0.001obtained abs = 57.0471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 347.20 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.450438; expected ratio = 0.0001obtained abs = 3.20532e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0934415; expected ratio = 0.001obtained abs = 41.9068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 342.47 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 450.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.543503; expected ratio = 0.0001obtained abs = 2.78508e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0795049; expected ratio = 0.001obtained abs = 34.6485; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.821040e+05 Mflops = 345.61 -Solve time = 0.00 -Solve flops = 1.667800e+04 Mflops = 489.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.694234; expected ratio = 0.0001obtained abs = 2.42252e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185234; expected ratio = 0.001obtained abs = 71.1109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869620e+05 Mflops = 354.03 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 500.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.613823; expected ratio = 0.0001obtained abs = 3.92629e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116995; expected ratio = 0.001obtained abs = 47.3017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861780e+05 Mflops = 352.70 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.15681; expected ratio = 0.0001obtained abs = 9.77135e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0604611; expected ratio = 0.001obtained abs = 25.0512; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816220e+05 Mflops = 349.28 -Solve time = 0.00 -Solve flops = 1.671200e+04 Mflops = 480.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.241775; expected ratio = 0.0001obtained abs = 1.81189e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0976816; expected ratio = 0.001obtained abs = 42.8525; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 347.22 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 490.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.492581; expected ratio = 0.0001obtained abs = 3.00362e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0805338; expected ratio = 0.001obtained abs = 35.7467; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 343.71 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.729635; expected ratio = 0.0001obtained abs = 2.92031e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.151482; expected ratio = 0.001obtained abs = 60.7867; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847280e+05 Mflops = 349.17 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 493.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.426435; expected ratio = 0.0001obtained abs = 2.22826e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0545566; expected ratio = 0.001obtained abs = 21.5322; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 352.96 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 496.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.370278; expected ratio = 0.0001obtained abs = 2.63408e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108382; expected ratio = 0.001obtained abs = 45.9212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.785480e+05 Mflops = 345.91 -Solve time = 0.00 -Solve flops = 1.654600e+04 Mflops = 488.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.39857; expected ratio = 0.0001obtained abs = 2.80102e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0758607; expected ratio = 0.001obtained abs = 33.5126; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 344.34 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.426427; expected ratio = 0.0001obtained abs = 2.31171e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0548049; expected ratio = 0.001obtained abs = 23.9719; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806800e+05 Mflops = 344.15 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.663507; expected ratio = 0.0001obtained abs = 2.44378e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170021; expected ratio = 0.001obtained abs = 66.3789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 352.51 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.613052; expected ratio = 0.0001obtained abs = 4.34594e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.143061; expected ratio = 0.001obtained abs = 60.2963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792260e+05 Mflops = 347.22 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.497225; expected ratio = 0.0001obtained abs = 4.2611e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145336; expected ratio = 0.001obtained abs = 67.1865; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 344.92 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 491.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.08131; expected ratio = 0.0001obtained abs = 5.03451e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.150952; expected ratio = 0.001obtained abs = 65.6785; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841540e+05 Mflops = 348.08 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 492.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.472021; expected ratio = 0.0001obtained abs = 1.76035e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.173973; expected ratio = 0.001obtained abs = 66.7828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.694125 - Final Residual ratio : 0.000535144 - Residual ratio : 0.000770962 - Slope : -0.0301561 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.693703 - Final Residual ratio : 0.000528895 - Residual ratio : 0.000762423 - Slope : -0.030138 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.692974 - Final Residual ratio : 0.000511649 - Residual ratio : 0.000738337 - Slope : -0.0301071 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.691887 - Final Residual ratio : 0.000495451 - Residual ratio : 0.000716087 - Slope : -0.0300605 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.667722 - Final Residual ratio : 0.00048294 - Residual ratio : 0.000723265 - Slope : -0.0290104 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.0638 - Final Residual ratio : 0.0391245 - Residual ratio : 0.000952773 - Slope : -1.78368 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9321 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.016 - Final Residual ratio : 0.00889535 - Residual ratio : 0.000634655 - Slope : -0.538737 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.47917 - Final Residual ratio : 0.00383618 - Residual ratio : 0.000856449 - Slope : -0.19458 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.9193 - Final Residual ratio : 0.0213092 - Residual ratio : 0.000972167 - Slope : -0.995364 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.84433 - Final Residual ratio : 0.00599853 - Residual ratio : 0.000764696 - Slope : -0.313533 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869620e+05 Mflops = 351.49 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 496.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.476974; expected ratio = 0.0001obtained abs = 2.57051e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0889606; expected ratio = 0.001obtained abs = 35.7183; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858840e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.688000e+04 Mflops = 498.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.171583; expected ratio = 0.0001obtained abs = 9.60049e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0449589; expected ratio = 0.001obtained abs = 18.5076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800020e+05 Mflops = 348.24 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.287113; expected ratio = 0.0001obtained abs = 1.40823e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0300142; expected ratio = 0.001obtained abs = 12.2064; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869620e+05 Mflops = 353.39 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 500.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.25846; expected ratio = 0.0001obtained abs = 1.30306e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0166477; expected ratio = 0.001obtained abs = 6.75275; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866020e+05 Mflops = 352.08 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 499.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.086549; expected ratio = 0.0001obtained abs = 4.60691e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0245731; expected ratio = 0.001obtained abs = 10.1318; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 350.53 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 481.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.222468; expected ratio = 0.0001obtained abs = 1.09843e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0237965; expected ratio = 0.001obtained abs = 9.70703; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869620e+05 Mflops = 352.76 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 483.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.250602; expected ratio = 0.0001obtained abs = 1.24297e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161224; expected ratio = 0.001obtained abs = 6.53709; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866020e+05 Mflops = 344.94 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 496.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.112648; expected ratio = 0.0001obtained abs = 6.01146e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0228765; expected ratio = 0.001obtained abs = 9.41858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 350.69 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 494.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.222235; expected ratio = 0.0001obtained abs = 1.10576e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0177211; expected ratio = 0.001obtained abs = 7.24085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834740e+05 Mflops = 348.84 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 478.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.231957; expected ratio = 0.0001obtained abs = 1.15715e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0147157; expected ratio = 0.001obtained abs = 5.95661; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866020e+05 Mflops = 352.71 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 482.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.128945; expected ratio = 0.0001obtained abs = 6.89175e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0256303; expected ratio = 0.001obtained abs = 10.5545; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 350.69 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.221471; expected ratio = 0.0001obtained abs = 1.10987e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0185825; expected ratio = 0.001obtained abs = 7.60286; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834740e+05 Mflops = 347.58 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 492.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.23884; expected ratio = 0.0001obtained abs = 1.18748e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0172979; expected ratio = 0.001obtained abs = 6.99812; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866020e+05 Mflops = 352.08 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 496.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.138056; expected ratio = 0.0001obtained abs = 7.356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0248562; expected ratio = 0.001obtained abs = 10.2225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 342.21 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.215971; expected ratio = 0.0001obtained abs = 1.09606e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0149111; expected ratio = 0.001obtained abs = 6.11388; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822580e+05 Mflops = 351.15 -Solve time = 0.00 -Solve flops = 1.674600e+04 Mflops = 491.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.248385; expected ratio = 0.0001obtained abs = 1.2251e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0207718; expected ratio = 0.001obtained abs = 8.3943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866020e+05 Mflops = 352.08 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 496.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.144695; expected ratio = 0.0001obtained abs = 7.69757e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.026495; expected ratio = 0.001obtained abs = 10.8853; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 346.71 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.212429; expected ratio = 0.0001obtained abs = 1.09114e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0147215; expected ratio = 0.001obtained abs = 6.04901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438213 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.35 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.166911; expected ratio = 0.0001obtained abs = 7.76179e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.024606; expected ratio = 0.001obtained abs = 9.93784; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866020e+05 Mflops = 353.35 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 499.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.235424; expected ratio = 0.0001obtained abs = 1.25082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0256744; expected ratio = 0.001obtained abs = 10.5266; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.15564 - Final Residual ratio : 0.00418034 - Residual ratio : 0.000810828 - Slope : -0.198133 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.52976 - Final Residual ratio : 0.00348873 - Residual ratio : 0.000988376 - Slope : -0.153316 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.78959 - Final Residual ratio : 0.00216046 - Residual ratio : 0.000774474 - Slope : -0.099551 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9391 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.26053 - Final Residual ratio : 0.00126225 - Residual ratio : 0.000558386 - Slope : -0.0779056 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.95437 - Final Residual ratio : 0.00128905 - Residual ratio : 0.000659571 - Slope : -0.0673476 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.59372 - Final Residual ratio : 0.00126315 - Residual ratio : 0.000792579 - Slope : -0.0549124 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41288 - Final Residual ratio : 0.00132985 - Residual ratio : 0.000941236 - Slope : -0.0542904 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.331 - Final Residual ratio : 0.00115072 - Residual ratio : 0.000864557 - Slope : -0.0511479 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29153 - Final Residual ratio : 0.00111905 - Residual ratio : 0.000866452 - Slope : -0.0496311 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35634 - Final Residual ratio : 0.00126078 - Residual ratio : 0.000929546 - Slope : -0.054203 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866020e+05 Mflops = 344.94 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 482.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.212775; expected ratio = 0.0001obtained abs = 1.24156e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0405467; expected ratio = 0.001obtained abs = 17.0832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813420e+05 Mflops = 346.20 -Solve time = 0.00 -Solve flops = 1.669400e+04 Mflops = 489.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.157452; expected ratio = 0.0001obtained abs = 8.59965e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.033171; expected ratio = 0.001obtained abs = 13.8861; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822580e+05 Mflops = 349.22 -Solve time = 0.00 -Solve flops = 1.674600e+04 Mflops = 491.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.286722; expected ratio = 0.0001obtained abs = 1.36953e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0582119; expected ratio = 0.001obtained abs = 23.4519; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858420e+05 Mflops = 350.01 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 481.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.353238; expected ratio = 0.0001obtained abs = 2.28802e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0951434; expected ratio = 0.001obtained abs = 40.6112; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.790920e+05 Mflops = 344.41 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.210371; expected ratio = 0.0001obtained abs = 1.26932e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0671275; expected ratio = 0.001obtained abs = 29.2141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816100e+05 Mflops = 347.82 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 493.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.424342; expected ratio = 0.0001obtained abs = 1.91428e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.081518; expected ratio = 0.001obtained abs = 33.5744; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843680e+05 Mflops = 347.24 -Solve time = 0.00 -Solve flops = 1.680200e+04 Mflops = 479.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.305826; expected ratio = 0.0001obtained abs = 1.36334e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0591347; expected ratio = 0.001obtained abs = 23.5214; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858420e+05 Mflops = 344.14 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 498.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.441155; expected ratio = 0.0001obtained abs = 2.80844e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0969151; expected ratio = 0.001obtained abs = 40.9089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.786500e+05 Mflops = 343.56 -Solve time = 0.00 -Solve flops = 1.655200e+04 Mflops = 488.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.281302; expected ratio = 0.0001obtained abs = 1.95246e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0898104; expected ratio = 0.001obtained abs = 39.9125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 345.95 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.535004; expected ratio = 0.0001obtained abs = 2.61478e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0772661; expected ratio = 0.001obtained abs = 33.3338; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812920e+05 Mflops = 342.06 -Solve time = 0.00 -Solve flops = 1.666600e+04 Mflops = 488.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.537022; expected ratio = 0.0001obtained abs = 1.96038e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.152217; expected ratio = 0.001obtained abs = 59.1253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 341.56 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.539102; expected ratio = 0.0001obtained abs = 3.54519e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.132723; expected ratio = 0.001obtained abs = 55.6739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792260e+05 Mflops = 345.94 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 486.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.442192; expected ratio = 0.0001obtained abs = 3.85522e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.152568; expected ratio = 0.001obtained abs = 70.8422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 343.67 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.38842; expected ratio = 0.0001obtained abs = 5.83482e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189225; expected ratio = 0.001obtained abs = 81.63; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841540e+05 Mflops = 346.21 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 478.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.529; expected ratio = 0.0001obtained abs = 1.85562e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.233189; expected ratio = 0.001obtained abs = 86.8242; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.864100e+05 Mflops = 351.08 -Solve time = 0.00 -Solve flops = 1.690800e+04 Mflops = 482.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.63194; expected ratio = 0.0001obtained abs = 4.65394e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.176275; expected ratio = 0.001obtained abs = 73.9538; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792260e+05 Mflops = 345.30 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 486.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.455724; expected ratio = 0.0001obtained abs = 4.20082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.168825; expected ratio = 0.001obtained abs = 79.2401; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 343.05 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 475.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.59811; expected ratio = 0.0001obtained abs = 6.59179e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.217377; expected ratio = 0.001obtained abs = 93.8722; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832740e+05 Mflops = 337.60 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.53113; expected ratio = 0.0001obtained abs = 1.92405e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.26371; expected ratio = 0.001obtained abs = 97.5671; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.864100e+05 Mflops = 350.45 -Solve time = 0.00 -Solve flops = 1.690800e+04 Mflops = 495.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.632257; expected ratio = 0.0001obtained abs = 4.73003e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189263; expected ratio = 0.001obtained abs = 79.3082; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19377 - Final Residual ratio : 0.000956437 - Residual ratio : 0.000801193 - Slope : -0.0426003 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09584 - Final Residual ratio : 0.000833896 - Residual ratio : 0.000760966 - Slope : -0.0391073 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.991292 - Final Residual ratio : 0.000943622 - Residual ratio : 0.000951911 - Slope : -0.0366796 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.893013 - Final Residual ratio : 0.000788451 - Residual ratio : 0.000882911 - Slope : -0.0343163 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.910686 - Final Residual ratio : 0.000856112 - Residual ratio : 0.000940074 - Slope : -0.0379096 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.774485 - Final Residual ratio : 0.000556425 - Residual ratio : 0.000718445 - Slope : -0.028664 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.745657 - Final Residual ratio : 0.000463395 - Residual ratio : 0.000621458 - Slope : -0.0275998 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.742675 - Final Residual ratio : 0.000441594 - Residual ratio : 0.000594599 - Slope : -0.0274901 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.749215 - Final Residual ratio : 0.000372771 - Residual ratio : 0.000497549 - Slope : -0.0277349 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.854255 - Final Residual ratio : 0.000658985 - Residual ratio : 0.000771416 - Slope : -0.0371129 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792260e+05 Mflops = 344.04 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 486.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.502476; expected ratio = 0.0001obtained abs = 4.96863e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.186537; expected ratio = 0.001obtained abs = 88.6625; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 342.27 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 491.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.46503; expected ratio = 0.0001obtained abs = 6.64487e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.214401; expected ratio = 0.001obtained abs = 93.9239; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832740e+05 Mflops = 344.40 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 494.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.434369; expected ratio = 0.0001obtained abs = 1.77134e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.203964; expected ratio = 0.001obtained abs = 78.169; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.872120e+05 Mflops = 354.02 -Solve time = 0.00 -Solve flops = 1.695400e+04 Mflops = 483.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.501582; expected ratio = 0.0001obtained abs = 3.35424e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121545; expected ratio = 0.001obtained abs = 50.4422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813520e+05 Mflops = 344.65 -Solve time = 0.00 -Solve flops = 1.667400e+04 Mflops = 492.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.485309; expected ratio = 0.0001obtained abs = 4.59193e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.154691; expected ratio = 0.001obtained abs = 70.9647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796060e+05 Mflops = 347.47 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.98197; expected ratio = 0.0001obtained abs = 5.09351e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131593; expected ratio = 0.001obtained abs = 57.5332; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 349.15 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 477.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.51662; expected ratio = 0.0001obtained abs = 2.23692e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.143189; expected ratio = 0.001obtained abs = 56.7283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869620e+05 Mflops = 353.55 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 483.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.354084; expected ratio = 0.0001obtained abs = 1.85457e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0616781; expected ratio = 0.001obtained abs = 24.5014; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 344.27 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 486.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.358234; expected ratio = 0.0001obtained abs = 2.47154e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104344; expected ratio = 0.001obtained abs = 44.1601; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804260e+05 Mflops = 345.71 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.412793; expected ratio = 0.0001obtained abs = 3.42921e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108489; expected ratio = 0.001obtained abs = 49.298; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807200e+05 Mflops = 342.98 -Solve time = 0.00 -Solve flops = 1.663200e+04 Mflops = 487.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.573777; expected ratio = 0.0001obtained abs = 3.25189e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0888654; expected ratio = 0.001obtained abs = 39.2183; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 341.85 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.589891; expected ratio = 0.0001obtained abs = 2.41385e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.147116; expected ratio = 0.001obtained abs = 58.72; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847280e+05 Mflops = 345.28 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 493.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.388699; expected ratio = 0.0001obtained abs = 1.95168e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0717051; expected ratio = 0.001obtained abs = 28.2725; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.830900e+05 Mflops = 352.10 -Solve time = 0.00 -Solve flops = 1.676000e+04 Mflops = 478.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.694508; expected ratio = 0.0001obtained abs = 7.70859e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.244003; expected ratio = 0.001obtained abs = 114.182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.778440e+05 Mflops = 343.91 -Solve time = 0.00 -Solve flops = 1.651000e+04 Mflops = 487.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.03173; expected ratio = 0.0001obtained abs = 6.0775e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.200576; expected ratio = 0.001obtained abs = 90.0132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 334.76 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.464523; expected ratio = 0.0001obtained abs = 2.35565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.153864; expected ratio = 0.001obtained abs = 63.7414; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.836480e+05 Mflops = 345.88 -Solve time = 0.00 -Solve flops = 1.678800e+04 Mflops = 479.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.345096; expected ratio = 0.0001obtained abs = 1.64766e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0894244; expected ratio = 0.001obtained abs = 35.9351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 352.17 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 496.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.396074; expected ratio = 0.0001obtained abs = 2.56657e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0899806; expected ratio = 0.001obtained abs = 37.7774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.803400e+05 Mflops = 341.49 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 487.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.480099; expected ratio = 0.0001obtained abs = 4.1727e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139474; expected ratio = 0.001obtained abs = 64.2538; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 339.06 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 475.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.00078; expected ratio = 0.0001obtained abs = 4.82239e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.150162; expected ratio = 0.001obtained abs = 65.3105; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.763744 - Final Residual ratio : 0.000621902 - Residual ratio : 0.000814281 - Slope : -0.0331792 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.751586 - Final Residual ratio : 0.000651776 - Residual ratio : 0.000867202 - Slope : -0.0288821 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.739275 - Final Residual ratio : 0.000536854 - Residual ratio : 0.000726191 - Slope : -0.0273607 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.724542 - Final Residual ratio : 0.000564992 - Residual ratio : 0.000779792 - Slope : -0.026814 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.799921 - Final Residual ratio : 0.000567192 - Residual ratio : 0.000709061 - Slope : -0.0296057 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.699691 - Final Residual ratio : 0.000683194 - Residual ratio : 0.000976423 - Slope : -0.0279603 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.683705 - Final Residual ratio : 0.000580766 - Residual ratio : 0.000849439 - Slope : -0.0297011 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.67624 - Final Residual ratio : 0.000362146 - Residual ratio : 0.000535528 - Slope : -0.029386 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.67315 - Final Residual ratio : 0.000329254 - Residual ratio : 0.000489124 - Slope : -0.0292531 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.759916 - Final Residual ratio : 0.000349932 - Residual ratio : 0.000460488 - Slope : -0.0330246 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832740e+05 Mflops = 342.56 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 477.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.515879; expected ratio = 0.0001obtained abs = 2.1083e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164105; expected ratio = 0.001obtained abs = 63.4999; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.872120e+05 Mflops = 351.96 -Solve time = 0.00 -Solve flops = 1.695400e+04 Mflops = 497.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.535043; expected ratio = 0.0001obtained abs = 3.39346e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0999052; expected ratio = 0.001obtained abs = 41.2825; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858420e+05 Mflops = 350.80 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 494.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.399874; expected ratio = 0.0001obtained abs = 3.42476e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.143238; expected ratio = 0.001obtained abs = 65.3958; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 342.27 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 491.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.730331; expected ratio = 0.0001obtained abs = 3.99295e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122303; expected ratio = 0.001obtained abs = 54.6202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808500e+05 Mflops = 340.61 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 488.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.991262; expected ratio = 0.0001obtained abs = 3.299e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.229577; expected ratio = 0.001obtained abs = 89.7792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.873140e+05 Mflops = 352.15 -Solve time = 0.00 -Solve flops = 1.695400e+04 Mflops = 497.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.588237; expected ratio = 0.0001obtained abs = 3.53565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127025; expected ratio = 0.001obtained abs = 51.0783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.854360e+05 Mflops = 354.50 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 484.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.531435; expected ratio = 0.0001obtained abs = 5.05917e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.176779; expected ratio = 0.001obtained abs = 80.2645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796060e+05 Mflops = 345.40 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 490.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.613826; expected ratio = 0.0001obtained abs = 4.01414e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.12074; expected ratio = 0.001obtained abs = 54.9204; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 341.70 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.774717; expected ratio = 0.0001obtained abs = 3.37388e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.17126; expected ratio = 0.001obtained abs = 71.1119; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866980e+05 Mflops = 350.37 -Solve time = 0.00 -Solve flops = 1.692600e+04 Mflops = 496.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.291579; expected ratio = 0.0001obtained abs = 1.32048e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.118923; expected ratio = 0.001obtained abs = 47.0123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869020e+05 Mflops = 347.48 -Solve time = 0.00 -Solve flops = 1.693400e+04 Mflops = 483.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.504612; expected ratio = 0.0001obtained abs = 3.4586e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101689; expected ratio = 0.001obtained abs = 42.6263; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796620e+05 Mflops = 345.51 -Solve time = 0.00 -Solve flops = 1.661000e+04 Mflops = 487.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.556537; expected ratio = 0.0001obtained abs = 6.29723e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185512; expected ratio = 0.001obtained abs = 88.237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795240e+05 Mflops = 343.98 -Solve time = 0.00 -Solve flops = 1.659400e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.10824; expected ratio = 0.0001obtained abs = 6.44529e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.182214; expected ratio = 0.001obtained abs = 80.6545; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.860460e+05 Mflops = 349.61 -Solve time = 0.00 -Solve flops = 1.688800e+04 Mflops = 498.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.578016; expected ratio = 0.0001obtained abs = 2.62142e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.149102; expected ratio = 0.001obtained abs = 60.3853; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.882160e+05 Mflops = 353.21 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 497.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.366128; expected ratio = 0.0001obtained abs = 1.58337e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100624; expected ratio = 0.001obtained abs = 39.4569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859800e+05 Mflops = 350.27 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.635228; expected ratio = 0.0001obtained abs = 5.49831e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.179353; expected ratio = 0.001obtained abs = 78.4127; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.768680e+05 Mflops = 342.18 -Solve time = 0.00 -Solve flops = 1.645600e+04 Mflops = 482.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.487637; expected ratio = 0.0001obtained abs = 3.82843e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120273; expected ratio = 0.001obtained abs = 54.1879; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811200e+05 Mflops = 342.35 -Solve time = 0.00 -Solve flops = 1.665600e+04 Mflops = 491.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.719523; expected ratio = 0.0001obtained abs = 3.71212e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10539; expected ratio = 0.001obtained abs = 45.0393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818620e+05 Mflops = 347.83 -Solve time = 0.00 -Solve flops = 1.671800e+04 Mflops = 490.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.639114; expected ratio = 0.0001obtained abs = 2.5079e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.147869; expected ratio = 0.001obtained abs = 58.0947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861280e+05 Mflops = 351.18 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 495.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.581293; expected ratio = 0.0001obtained abs = 4.01007e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129753; expected ratio = 0.001obtained abs = 54.5827; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.678424 - Final Residual ratio : 0.000261633 - Residual ratio : 0.000385648 - Slope : -0.0294853 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.674949 - Final Residual ratio : 0.000263553 - Residual ratio : 0.000390478 - Slope : -0.0293342 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9681 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.674197 - Final Residual ratio : 0.000395081 - Residual ratio : 0.000586002 - Slope : -0.0292957 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.672396 - Final Residual ratio : 0.000561341 - Residual ratio : 0.000834838 - Slope : -0.0292102 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.9094 - Final Residual ratio : 0.0429557 - Residual ratio : 0.000860674 - Slope : -1.99466 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.201 - Final Residual ratio : 0.0112882 - Residual ratio : 0.000742595 - Slope : -0.562581 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.18966 - Final Residual ratio : 0.00516573 - Residual ratio : 0.000995388 - Slope : -0.216021 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.53998 - Final Residual ratio : 0.00401528 - Residual ratio : 0.000884429 - Slope : -0.167999 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.8491 - Final Residual ratio : 0.0269473 - Residual ratio : 0.000820335 - Slope : -1.49192 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.6945 - Final Residual ratio : 0.0115625 - Residual ratio : 0.000910826 - Slope : -0.603952 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.799980e+05 Mflops = 344.73 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 477.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.97498; expected ratio = 0.0001obtained abs = 2.88668e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137749; expected ratio = 0.001obtained abs = 61.3891; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.790000e+05 Mflops = 335.92 -Solve time = 0.00 -Solve flops = 1.654600e+04 Mflops = 485.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.25842; expected ratio = 0.0001obtained abs = 3.0813e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0977225; expected ratio = 0.001obtained abs = 42.9044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.784620e+05 Mflops = 339.77 -Solve time = 0.00 -Solve flops = 1.651400e+04 Mflops = 487.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.926881; expected ratio = 0.0001obtained abs = 3.25719e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.186573; expected ratio = 0.001obtained abs = 72.8066; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861780e+05 Mflops = 342.95 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.524265; expected ratio = 0.0001obtained abs = 3.14689e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.124334; expected ratio = 0.001obtained abs = 50.9975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792260e+05 Mflops = 346.10 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 486.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.570214; expected ratio = 0.0001obtained abs = 5.22244e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.167778; expected ratio = 0.001obtained abs = 76.9327; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816920e+05 Mflops = 344.83 -Solve time = 0.00 -Solve flops = 1.668800e+04 Mflops = 489.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.13795; expected ratio = 0.0001obtained abs = 5.44686e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.157236; expected ratio = 0.001obtained abs = 68.4901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816840e+05 Mflops = 348.12 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 490.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.485405; expected ratio = 0.0001obtained abs = 1.9825e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.153219; expected ratio = 0.001obtained abs = 59.7347; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834740e+05 Mflops = 344.93 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 492.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.529164; expected ratio = 0.0001obtained abs = 3.16296e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0823691; expected ratio = 0.001obtained abs = 33.658; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818980e+05 Mflops = 348.53 -Solve time = 0.00 -Solve flops = 1.672600e+04 Mflops = 490.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.104251; expected ratio = 0.0001obtained abs = 5.80999e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0344085; expected ratio = 0.001obtained abs = 14.1998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805460e+05 Mflops = 345.94 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.316202; expected ratio = 0.0001obtained abs = 2.05085e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0698269; expected ratio = 0.001obtained abs = 30.087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 341.85 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.280152; expected ratio = 0.0001obtained abs = 1.522e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0738908; expected ratio = 0.001obtained abs = 31.6366; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826040e+05 Mflops = 343.91 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 490.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.663935; expected ratio = 0.0001obtained abs = 2.47078e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144367; expected ratio = 0.001obtained abs = 56.2623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823900e+05 Mflops = 344.75 -Solve time = 0.00 -Solve flops = 1.672000e+04 Mflops = 493.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.549612; expected ratio = 0.0001obtained abs = 3.4608e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113669; expected ratio = 0.001obtained abs = 47.1021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 345.11 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 489.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.43058; expected ratio = 0.0001obtained abs = 3.32636e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.114892; expected ratio = 0.001obtained abs = 50.8109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 341.85 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.656913; expected ratio = 0.0001obtained abs = 3.44473e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0849167; expected ratio = 0.001obtained abs = 36.9486; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796340e+05 Mflops = 344.82 -Solve time = 0.00 -Solve flops = 1.660200e+04 Mflops = 500.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.549171; expected ratio = 0.0001obtained abs = 2.17488e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131695; expected ratio = 0.001obtained abs = 52.0238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818980e+05 Mflops = 347.74 -Solve time = 0.00 -Solve flops = 1.672600e+04 Mflops = 490.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.545581; expected ratio = 0.0001obtained abs = 3.29539e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0860063; expected ratio = 0.001obtained abs = 35.475; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808860e+05 Mflops = 346.43 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 492.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.303673; expected ratio = 0.0001obtained abs = 2.02294e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0736448; expected ratio = 0.001obtained abs = 31.8949; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 342.32 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.224689; expected ratio = 0.0001obtained abs = 1.30983e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0589316; expected ratio = 0.001obtained abs = 25.8842; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 341.08 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.561096; expected ratio = 0.0001obtained abs = 2.26116e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.132822; expected ratio = 0.001obtained abs = 53.3682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.16193 - Final Residual ratio : 0.00298643 - Residual ratio : 0.000717559 - Slope : -0.148534 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.60938 - Final Residual ratio : 0.00335473 - Residual ratio : 0.000929448 - Slope : -0.128787 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.49754 - Final Residual ratio : 0.00250891 - Residual ratio : 0.000717334 - Slope : -0.124823 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.06064 - Final Residual ratio : 0.00238127 - Residual ratio : 0.000778031 - Slope : -0.109223 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.46978 - Final Residual ratio : 0.00171308 - Residual ratio : 0.000693619 - Slope : -0.0914098 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.96015 - Final Residual ratio : 0.00153197 - Residual ratio : 0.00078156 - Slope : -0.0851572 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.6635 - Final Residual ratio : 0.00146247 - Residual ratio : 0.000879154 - Slope : -0.118717 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55672 - Final Residual ratio : 0.00122311 - Residual ratio : 0.000785696 - Slope : -0.057611 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51124 - Final Residual ratio : 0.00135569 - Residual ratio : 0.000897067 - Slope : -0.0580725 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49245 - Final Residual ratio : 0.00142446 - Residual ratio : 0.000954439 - Slope : -0.0596412 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847280e+05 Mflops = 339.53 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 483.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.332365; expected ratio = 0.0001obtained abs = 1.55448e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0684389; expected ratio = 0.001obtained abs = 27.0523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 352.96 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 482.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.521186; expected ratio = 0.0001obtained abs = 3.99876e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139169; expected ratio = 0.001obtained abs = 60.5456; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.780840e+05 Mflops = 341.22 -Solve time = 0.00 -Solve flops = 1.649400e+04 Mflops = 501.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.331707; expected ratio = 0.0001obtained abs = 2.38302e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0810358; expected ratio = 0.001obtained abs = 36.0605; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.793020e+05 Mflops = 345.61 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 486.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.655654; expected ratio = 0.0001obtained abs = 3.11099e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0980987; expected ratio = 0.001obtained abs = 41.0848; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813880e+05 Mflops = 347.55 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 489.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.376913; expected ratio = 0.0001obtained abs = 1.57802e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0968087; expected ratio = 0.001obtained abs = 38.2457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 352.03 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 499.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.419248; expected ratio = 0.0001obtained abs = 2.57756e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103235; expected ratio = 0.001obtained abs = 43.3712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804420e+05 Mflops = 338.47 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 474.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.288322; expected ratio = 0.0001obtained abs = 2.0365e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0930493; expected ratio = 0.001obtained abs = 40.711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 345.93 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.42055; expected ratio = 0.0001obtained abs = 2.31963e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0506447; expected ratio = 0.001obtained abs = 21.9817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 345.21 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 494.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.424775; expected ratio = 0.0001obtained abs = 1.7974e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113126; expected ratio = 0.001obtained abs = 45.5955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831340e+05 Mflops = 346.94 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 491.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.547518; expected ratio = 0.0001obtained abs = 4.25571e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.15763; expected ratio = 0.001obtained abs = 70.1782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 343.71 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.618975; expected ratio = 0.0001obtained abs = 3.16843e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140354; expected ratio = 0.001obtained abs = 60.7478; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834740e+05 Mflops = 346.80 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 492.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.605648; expected ratio = 0.0001obtained abs = 2.37769e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.165855; expected ratio = 0.001obtained abs = 64.332; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.865560e+05 Mflops = 352.62 -Solve time = 0.00 -Solve flops = 1.691400e+04 Mflops = 482.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.447383; expected ratio = 0.0001obtained abs = 2.67634e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0866541; expected ratio = 0.001obtained abs = 35.4811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839660e+05 Mflops = 355.09 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 496.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.691781; expected ratio = 0.0001obtained abs = 8.53331e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.257339; expected ratio = 0.001obtained abs = 126.834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.785740e+05 Mflops = 344.05 -Solve time = 0.00 -Solve flops = 1.654200e+04 Mflops = 485.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.507; expected ratio = 0.0001obtained abs = 8.13167e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.273049; expected ratio = 0.001obtained abs = 121.398; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839840e+05 Mflops = 347.76 -Solve time = 0.00 -Solve flops = 1.677200e+04 Mflops = 495.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.939922; expected ratio = 0.0001obtained abs = 3.39166e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243255; expected ratio = 0.001obtained abs = 93.8347; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 350.61 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.529124; expected ratio = 0.0001obtained abs = 3.18583e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.142366; expected ratio = 0.001obtained abs = 58.5821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801360e+05 Mflops = 347.70 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 477.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.555493; expected ratio = 0.0001obtained abs = 5.32046e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.180042; expected ratio = 0.001obtained abs = 83.2747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796060e+05 Mflops = 348.12 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.00223; expected ratio = 0.0001obtained abs = 5.16761e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.154127; expected ratio = 0.001obtained abs = 67.7245; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813880e+05 Mflops = 344.10 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 492.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.559147; expected ratio = 0.0001obtained abs = 2.332e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.156874; expected ratio = 0.001obtained abs = 62.1246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30741 - Final Residual ratio : 0.000905754 - Residual ratio : 0.000692786 - Slope : -0.0568045 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15785 - Final Residual ratio : 0.000656074 - Residual ratio : 0.000566633 - Slope : -0.0428589 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00835 - Final Residual ratio : 0.000718084 - Residual ratio : 0.000712136 - Slope : -0.0373198 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.88796 - Final Residual ratio : 0.000777603 - Residual ratio : 0.000875719 - Slope : -0.0328586 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.869961 - Final Residual ratio : 0.000756644 - Residual ratio : 0.000869744 - Slope : -0.0321928 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.749757 - Final Residual ratio : 0.000657206 - Residual ratio : 0.00087656 - Slope : -0.0277444 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.723054 - Final Residual ratio : 0.00060675 - Residual ratio : 0.000839148 - Slope : -0.0288979 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.715257 - Final Residual ratio : 0.000548543 - Residual ratio : 0.000766918 - Slope : -0.0285883 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.719228 - Final Residual ratio : 0.000701362 - Residual ratio : 0.000975159 - Slope : -0.0276356 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.807775 - Final Residual ratio : 0.000612961 - Residual ratio : 0.000758826 - Slope : -0.0298949 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 1.9951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.9951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869620e+05 Mflops = 350.08 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 483.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.271732; expected ratio = 0.0001obtained abs = 1.32459e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0756045; expected ratio = 0.001obtained abs = 29.9759; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866520e+05 Mflops = 352.81 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 482.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.367168; expected ratio = 0.0001obtained abs = 2.3819e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0964542; expected ratio = 0.001obtained abs = 40.6102; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814380e+05 Mflops = 349.73 -Solve time = 0.00 -Solve flops = 1.670000e+04 Mflops = 489.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.489057; expected ratio = 0.0001obtained abs = 4.73576e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146899; expected ratio = 0.001obtained abs = 68.3897; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795040e+05 Mflops = 345.84 -Solve time = 0.00 -Solve flops = 1.659400e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.844507; expected ratio = 0.0001obtained abs = 4.7574e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130415; expected ratio = 0.001obtained abs = 58.1229; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800760e+05 Mflops = 345.67 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 487.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.862091; expected ratio = 0.0001obtained abs = 3.15515e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19904; expected ratio = 0.001obtained abs = 77.8065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.864100e+05 Mflops = 352.98 -Solve time = 0.00 -Solve flops = 1.690800e+04 Mflops = 482.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.457456; expected ratio = 0.0001obtained abs = 2.64173e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108992; expected ratio = 0.001obtained abs = 44.9145; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.853040e+05 Mflops = 356.36 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 484.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.664294; expected ratio = 0.0001obtained abs = 7.90648e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.245837; expected ratio = 0.001obtained abs = 120.469; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802940e+05 Mflops = 342.18 -Solve time = 0.00 -Solve flops = 1.661000e+04 Mflops = 487.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.37116; expected ratio = 0.0001obtained abs = 7.4769e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.253926; expected ratio = 0.001obtained abs = 112.929; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 351.08 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.544959; expected ratio = 0.0001obtained abs = 2.39803e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.184521; expected ratio = 0.001obtained abs = 74.2964; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.882160e+05 Mflops = 355.76 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 484.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.281344; expected ratio = 0.0001obtained abs = 1.22788e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104659; expected ratio = 0.001obtained abs = 41.1109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843520e+05 Mflops = 356.49 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 497.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.761656; expected ratio = 0.0001obtained abs = 9.36785e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.265063; expected ratio = 0.001obtained abs = 124.63; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.783300e+05 Mflops = 340.30 -Solve time = 0.00 -Solve flops = 1.653800e+04 Mflops = 471.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.988728; expected ratio = 0.0001obtained abs = 6.60143e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.204076; expected ratio = 0.001obtained abs = 93.1937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.820680e+05 Mflops = 346.17 -Solve time = 0.00 -Solve flops = 1.671200e+04 Mflops = 490.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.505105; expected ratio = 0.0001obtained abs = 2.77723e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.142554; expected ratio = 0.001obtained abs = 62.052; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810280e+05 Mflops = 343.57 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.741737; expected ratio = 0.0001obtained abs = 2.62906e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.18391; expected ratio = 0.001obtained abs = 72.277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.863580e+05 Mflops = 353.05 -Solve time = 0.00 -Solve flops = 1.690200e+04 Mflops = 495.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.626867; expected ratio = 0.0001obtained abs = 4.67827e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166822; expected ratio = 0.001obtained abs = 70.8511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795560e+05 Mflops = 347.38 -Solve time = 0.00 -Solve flops = 1.660200e+04 Mflops = 486.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.411923; expected ratio = 0.0001obtained abs = 3.54558e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.128393; expected ratio = 0.001obtained abs = 58.5758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805720e+05 Mflops = 343.32 -Solve time = 0.00 -Solve flops = 1.662400e+04 Mflops = 487.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.847413; expected ratio = 0.0001obtained abs = 4.34868e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103213; expected ratio = 0.001obtained abs = 45.5196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816840e+05 Mflops = 348.60 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 493.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.540237; expected ratio = 0.0001obtained abs = 2.05979e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166635; expected ratio = 0.001obtained abs = 65.2423; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 352.67 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.495688; expected ratio = 0.0001obtained abs = 3.2449e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130771; expected ratio = 0.001obtained abs = 55.3966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 337.36 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.538544; expected ratio = 0.0001obtained abs = 5.04258e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164081; expected ratio = 0.001obtained abs = 77.6137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 1.9961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.730128 - Final Residual ratio : 0.000466418 - Residual ratio : 0.000638817 - Slope : -0.0270245 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.724271 - Final Residual ratio : 0.000600033 - Residual ratio : 0.000828465 - Slope : -0.0278335 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.71056 - Final Residual ratio : 0.000641636 - Residual ratio : 0.000903001 - Slope : -0.0295799 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 1.9991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.691194 - Final Residual ratio : 0.000412815 - Residual ratio : 0.000597249 - Slope : -0.030034 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 1.9991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.756155 - Final Residual ratio : 0.000720192 - Residual ratio : 0.000952439 - Slope : -0.0343379 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.651211 - Final Residual ratio : 0.000404753 - Residual ratio : 0.000621539 - Slope : -0.0282959 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.633782 - Final Residual ratio : 0.00033611 - Residual ratio : 0.000530325 - Slope : -0.0275411 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.62287 - Final Residual ratio : 0.000615446 - Residual ratio : 0.000988082 - Slope : -0.0282843 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.617612 - Final Residual ratio : 0.000336504 - Residual ratio : 0.000544846 - Slope : -0.0268381 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.703357 - Final Residual ratio : 0.000527517 - Residual ratio : 0.000749999 - Slope : -0.0292846 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 341.66 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.15199; expected ratio = 0.0001obtained abs = 6.05212e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.200994; expected ratio = 0.001obtained abs = 88.6627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831140e+05 Mflops = 351.50 -Solve time = 0.00 -Solve flops = 1.679200e+04 Mflops = 479.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.539858; expected ratio = 0.0001obtained abs = 2.69015e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166112; expected ratio = 0.001obtained abs = 65.6964; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.879140e+05 Mflops = 341.64 -Solve time = 0.00 -Solve flops = 1.699200e+04 Mflops = 484.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.640681; expected ratio = 0.0001obtained abs = 5.18029e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103887; expected ratio = 0.001obtained abs = 43.7163; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819120e+05 Mflops = 348.40 -Solve time = 0.00 -Solve flops = 1.672600e+04 Mflops = 490.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.644292; expected ratio = 0.0001obtained abs = 1.00049e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.262353; expected ratio = 0.001obtained abs = 132.176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.786500e+05 Mflops = 343.56 -Solve time = 0.00 -Solve flops = 1.654800e+04 Mflops = 488.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.77128; expected ratio = 0.0001obtained abs = 1.10048e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.33029; expected ratio = 0.001obtained abs = 149.942; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817080e+05 Mflops = 350.25 -Solve time = 0.00 -Solve flops = 1.672000e+04 Mflops = 490.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.918783; expected ratio = 0.0001obtained abs = 4.39049e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.25638; expected ratio = 0.001obtained abs = 102.396; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.865120e+05 Mflops = 351.91 -Solve time = 0.00 -Solve flops = 1.691400e+04 Mflops = 496.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.595514; expected ratio = 0.0001obtained abs = 5.0393e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139552; expected ratio = 0.001obtained abs = 60.2312; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 346.98 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 490.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.38753; expected ratio = 0.0001obtained abs = 3.53281e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.124571; expected ratio = 0.001obtained abs = 57.7852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813880e+05 Mflops = 344.88 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 475.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.817468; expected ratio = 0.0001obtained abs = 4.59026e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137097; expected ratio = 0.001obtained abs = 61.0581; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808500e+05 Mflops = 342.61 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 474.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.5591; expected ratio = 0.0001obtained abs = 2.2729e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19341; expected ratio = 0.001obtained abs = 75.7906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 351.24 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 485.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.645897; expected ratio = 0.0001obtained abs = 5.322e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146827; expected ratio = 0.001obtained abs = 62.5272; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792260e+05 Mflops = 345.94 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.412001; expected ratio = 0.0001obtained abs = 3.99917e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16171; expected ratio = 0.001obtained abs = 76.6292; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 343.05 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 488.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.04675; expected ratio = 0.0001obtained abs = 5.54561e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.17749; expected ratio = 0.001obtained abs = 78.5527; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796340e+05 Mflops = 345.46 -Solve time = 0.00 -Solve flops = 1.660200e+04 Mflops = 476.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.469277; expected ratio = 0.0001obtained abs = 1.94891e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.183891; expected ratio = 0.001obtained abs = 71.9901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 351.24 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 482.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.623901; expected ratio = 0.0001obtained abs = 4.86706e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1267; expected ratio = 0.001obtained abs = 53.221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813520e+05 Mflops = 344.03 -Solve time = 0.00 -Solve flops = 1.667400e+04 Mflops = 492.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.400416; expected ratio = 0.0001obtained abs = 4.06371e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.141228; expected ratio = 0.001obtained abs = 64.9154; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.788600e+05 Mflops = 344.60 -Solve time = 0.00 -Solve flops = 1.655800e+04 Mflops = 472.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.896117; expected ratio = 0.0001obtained abs = 5.37961e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101065; expected ratio = 0.001obtained abs = 44.9882; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813880e+05 Mflops = 343.63 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 475.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.472825; expected ratio = 0.0001obtained abs = 2.2468e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146096; expected ratio = 0.001obtained abs = 58.894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.882160e+05 Mflops = 354.48 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 497.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.497991; expected ratio = 0.0001obtained abs = 3.02588e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0964858; expected ratio = 0.001obtained abs = 38.3573; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839660e+05 Mflops = 353.79 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 493.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.748292; expected ratio = 0.0001obtained abs = 1.16228e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.308156; expected ratio = 0.001obtained abs = 153.307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.617753 - Final Residual ratio : 0.00057386 - Residual ratio : 0.000928949 - Slope : -0.0257158 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.618423 - Final Residual ratio : 0.000493676 - Residual ratio : 0.000798282 - Slope : -0.0247172 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.619409 - Final Residual ratio : 0.000448748 - Residual ratio : 0.000724478 - Slope : -0.0247584 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.618901 - Final Residual ratio : 0.000613784 - Residual ratio : 0.000991731 - Slope : -0.025762 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.705213 - Final Residual ratio : 0.000679677 - Residual ratio : 0.00096379 - Slope : -0.0293555 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.0111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.613654 - Final Residual ratio : 0.00050951 - Residual ratio : 0.000830289 - Slope : -0.0255477 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.607383 - Final Residual ratio : 0.000557126 - Residual ratio : 0.000917256 - Slope : -0.0263837 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.602557 - Final Residual ratio : 0.000511594 - Residual ratio : 0.000849039 - Slope : -0.0261759 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.598564 - Final Residual ratio : 0.000509131 - Residual ratio : 0.000850589 - Slope : -0.0260024 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.684151 - Final Residual ratio : 0.000538206 - Residual ratio : 0.000786677 - Slope : -0.0284839 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.785740e+05 Mflops = 342.16 -Solve time = 0.00 -Solve flops = 1.654200e+04 Mflops = 471.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.62529; expected ratio = 0.0001obtained abs = 1.05463e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.310071; expected ratio = 0.001obtained abs = 142.761; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813420e+05 Mflops = 348.74 -Solve time = 0.00 -Solve flops = 1.669400e+04 Mflops = 476.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.75772; expected ratio = 0.0001obtained abs = 4.81542e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.253071; expected ratio = 0.001obtained abs = 102.955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866980e+05 Mflops = 343.15 -Solve time = 0.00 -Solve flops = 1.692600e+04 Mflops = 499.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.445491; expected ratio = 0.0001obtained abs = 2.80695e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131797; expected ratio = 0.001obtained abs = 52.2326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861540e+05 Mflops = 356.04 -Solve time = 0.00 -Solve flops = 1.692200e+04 Mflops = 496.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.666173; expected ratio = 0.0001obtained abs = 7.41976e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.156119; expected ratio = 0.001obtained abs = 66.6203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 345.74 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 489.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.526266; expected ratio = 0.0001obtained abs = 8.75379e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.22478; expected ratio = 0.001obtained abs = 112.524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800100e+05 Mflops = 346.18 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 490.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.51227; expected ratio = 0.0001obtained abs = 1.10845e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.214042; expected ratio = 0.001obtained abs = 99.266; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.797600e+05 Mflops = 346.97 -Solve time = 0.00 -Solve flops = 1.660800e+04 Mflops = 490.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.601444; expected ratio = 0.0001obtained abs = 3.44177e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.196563; expected ratio = 0.001obtained abs = 82.4779; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859980e+05 Mflops = 353.64 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 494.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.594305; expected ratio = 0.0001obtained abs = 4.4206e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144702; expected ratio = 0.001obtained abs = 56.7454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.830900e+05 Mflops = 353.40 -Solve time = 0.00 -Solve flops = 1.676000e+04 Mflops = 481.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.707255; expected ratio = 0.0001obtained abs = 1.14163e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.272498; expected ratio = 0.001obtained abs = 127.687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.777860e+05 Mflops = 345.87 -Solve time = 0.00 -Solve flops = 1.650600e+04 Mflops = 484.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.798277; expected ratio = 0.0001obtained abs = 8.09606e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.187059; expected ratio = 0.001obtained abs = 89.5085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808240e+05 Mflops = 337.98 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 488.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.20178; expected ratio = 0.0001obtained abs = 6.43594e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.225778; expected ratio = 0.001obtained abs = 95.6973; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834740e+05 Mflops = 346.80 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 495.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.359296; expected ratio = 0.0001obtained abs = 2.00885e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139068; expected ratio = 0.001obtained abs = 55.2222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870040e+05 Mflops = 352.83 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 496.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.613498; expected ratio = 0.0001obtained abs = 5.7018e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102574; expected ratio = 0.001obtained abs = 42.4477; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838640e+05 Mflops = 355.71 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.61213; expected ratio = 0.0001obtained abs = 9.83764e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.260457; expected ratio = 0.001obtained abs = 130.552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.786700e+05 Mflops = 344.87 -Solve time = 0.00 -Solve flops = 1.654800e+04 Mflops = 475.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.6658; expected ratio = 0.0001obtained abs = 1.09274e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243869; expected ratio = 0.001obtained abs = 112.859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 343.09 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.601708; expected ratio = 0.0001obtained abs = 3.88455e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.169221; expected ratio = 0.001obtained abs = 73.293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843320e+05 Mflops = 346.55 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 496.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.600327; expected ratio = 0.0001obtained abs = 2.75577e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.201899; expected ratio = 0.001obtained abs = 78.7631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866980e+05 Mflops = 352.26 -Solve time = 0.00 -Solve flops = 1.692200e+04 Mflops = 496.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.755544; expected ratio = 0.0001obtained abs = 8.61696e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.192709; expected ratio = 0.001obtained abs = 83.0901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.786500e+05 Mflops = 345.46 -Solve time = 0.00 -Solve flops = 1.655200e+04 Mflops = 488.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.442322; expected ratio = 0.0001obtained abs = 5.27647e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.162931; expected ratio = 0.001obtained abs = 77.5537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795040e+05 Mflops = 345.84 -Solve time = 0.00 -Solve flops = 1.659400e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.18789; expected ratio = 0.0001obtained abs = 7.36e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.136485; expected ratio = 0.001obtained abs = 61.9031; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.595401 - Final Residual ratio : 0.000437124 - Residual ratio : 0.000734168 - Slope : -0.0247902 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.59322 - Final Residual ratio : 0.000415108 - Residual ratio : 0.000699754 - Slope : -0.0247002 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.592895 - Final Residual ratio : 0.000430646 - Residual ratio : 0.000726345 - Slope : -0.024686 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.592869 - Final Residual ratio : 0.000494471 - Residual ratio : 0.000834031 - Slope : -0.0246823 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.680642 - Final Residual ratio : 0.000635801 - Residual ratio : 0.00093412 - Slope : -0.0283336 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.593422 - Final Residual ratio : 0.000462173 - Residual ratio : 0.000778827 - Slope : -0.0247067 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.590709 - Final Residual ratio : 0.000435557 - Residual ratio : 0.000737346 - Slope : -0.0245947 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.589102 - Final Residual ratio : 0.000430887 - Residual ratio : 0.00073143 - Slope : -0.024528 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.587661 - Final Residual ratio : 0.000448957 - Residual ratio : 0.000763974 - Slope : -0.0244672 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.673588 - Final Residual ratio : 0.00064255 - Residual ratio : 0.000953921 - Slope : -0.0280394 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816520e+05 Mflops = 346.79 -Solve time = 0.00 -Solve flops = 1.671000e+04 Mflops = 490.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.00905; expected ratio = 0.0001obtained abs = 4.62641e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.215058; expected ratio = 0.001obtained abs = 84.6585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866020e+05 Mflops = 350.81 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 499.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.90126; expected ratio = 0.0001obtained abs = 4.63152e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123202; expected ratio = 0.001obtained abs = 50.9963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839660e+05 Mflops = 353.14 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 496.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.694509; expected ratio = 0.0001obtained abs = 7.6398e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.2516; expected ratio = 0.001obtained abs = 123.7; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802760e+05 Mflops = 340.14 -Solve time = 0.00 -Solve flops = 1.660600e+04 Mflops = 487.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.13753; expected ratio = 0.0001obtained abs = 8.58213e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.360318; expected ratio = 0.001obtained abs = 152.486; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831240e+05 Mflops = 350.24 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.607439; expected ratio = 0.0001obtained abs = 3.25342e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.194213; expected ratio = 0.001obtained abs = 76.8776; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.837780e+05 Mflops = 353.26 -Solve time = 0.00 -Solve flops = 1.680000e+04 Mflops = 496.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.67695; expected ratio = 0.0001obtained abs = 7.04815e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.204301; expected ratio = 0.001obtained abs = 93.8683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.774240e+05 Mflops = 343.25 -Solve time = 0.00 -Solve flops = 1.648800e+04 Mflops = 470.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.626986; expected ratio = 0.0001obtained abs = 4.83472e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120736; expected ratio = 0.001obtained abs = 55.1023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809520e+05 Mflops = 342.03 -Solve time = 0.00 -Solve flops = 1.664600e+04 Mflops = 488.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.980102; expected ratio = 0.0001obtained abs = 4.50889e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.161789; expected ratio = 0.001obtained abs = 67.1644; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847280e+05 Mflops = 342.68 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 493.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.467557; expected ratio = 0.0001obtained abs = 2.30656e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.085535; expected ratio = 0.001obtained abs = 34.2585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859800e+05 Mflops = 351.54 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.632682; expected ratio = 0.0001obtained abs = 5.63427e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166624; expected ratio = 0.001obtained abs = 74.4629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.768680e+05 Mflops = 342.65 -Solve time = 0.00 -Solve flops = 1.645600e+04 Mflops = 486.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.586302; expected ratio = 0.0001obtained abs = 4.49243e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102469; expected ratio = 0.001obtained abs = 46.0852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805180e+05 Mflops = 341.83 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 477.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.500304; expected ratio = 0.0001obtained abs = 2.8891e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0922667; expected ratio = 0.001obtained abs = 39.4967; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.824000e+05 Mflops = 348.70 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 491.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.635317; expected ratio = 0.0001obtained abs = 2.89564e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129076; expected ratio = 0.001obtained abs = 51.4779; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861280e+05 Mflops = 351.81 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 485.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.489976; expected ratio = 0.0001obtained abs = 2.97075e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0963723; expected ratio = 0.001obtained abs = 39.8587; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838280e+05 Mflops = 343.60 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.859466; expected ratio = 0.0001obtained abs = 1.41332e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.291436; expected ratio = 0.001obtained abs = 147.763; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.782080e+05 Mflops = 341.31 -Solve time = 0.00 -Solve flops = 1.652200e+04 Mflops = 488.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.75129; expected ratio = 0.0001obtained abs = 1.19375e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.301233; expected ratio = 0.001obtained abs = 137.129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.777320e+05 Mflops = 343.85 -Solve time = 0.00 -Solve flops = 1.649800e+04 Mflops = 483.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.691584; expected ratio = 0.0001obtained abs = 4.17186e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.186029; expected ratio = 0.001obtained abs = 80.1293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.862240e+05 Mflops = 350.73 -Solve time = 0.00 -Solve flops = 1.690000e+04 Mflops = 482.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.85758; expected ratio = 0.0001obtained abs = 3.52975e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.181731; expected ratio = 0.001obtained abs = 71.6728; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.880160e+05 Mflops = 352.84 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.535906; expected ratio = 0.0001obtained abs = 3.70919e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129532; expected ratio = 0.001obtained abs = 53.8465; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.854060e+05 Mflops = 354.44 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 481.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.68936; expected ratio = 0.0001obtained abs = 8.72332e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.238878; expected ratio = 0.001obtained abs = 118.214; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.586969 - Final Residual ratio : 0.000530163 - Residual ratio : 0.000903222 - Slope : -0.0244349 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.584585 - Final Residual ratio : 0.000517455 - Residual ratio : 0.000885167 - Slope : -0.0243362 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.583849 - Final Residual ratio : 0.000518837 - Residual ratio : 0.000888649 - Slope : -0.0243054 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.583445 - Final Residual ratio : 0.000481689 - Residual ratio : 0.000825594 - Slope : -0.0242901 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.669346 - Final Residual ratio : 0.000610119 - Residual ratio : 0.000911515 - Slope : -0.027864 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.584291 - Final Residual ratio : 0.00045573 - Residual ratio : 0.000779971 - Slope : -0.0243265 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.58203 - Final Residual ratio : 0.000429242 - Residual ratio : 0.000737492 - Slope : -0.0242334 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.581171 - Final Residual ratio : 0.000427348 - Residual ratio : 0.000735323 - Slope : -0.0241976 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.580533 - Final Residual ratio : 0.000436387 - Residual ratio : 0.000751701 - Slope : -0.0241707 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.665142 - Final Residual ratio : 0.00060877 - Residual ratio : 0.000915249 - Slope : -0.0276889 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.794660e+05 Mflops = 343.71 -Solve time = 0.00 -Solve flops = 1.659000e+04 Mflops = 473.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.28021; expected ratio = 0.0001obtained abs = 8.36071e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.255865; expected ratio = 0.001obtained abs = 115.513; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809860e+05 Mflops = 349.34 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 492.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.639199; expected ratio = 0.0001obtained abs = 5.14301e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.229641; expected ratio = 0.001obtained abs = 93.4223; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866160e+05 Mflops = 352.74 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 482.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.737944; expected ratio = 0.0001obtained abs = 5.60413e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120572; expected ratio = 0.001obtained abs = 48.6591; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839660e+05 Mflops = 354.44 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 493.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.730854; expected ratio = 0.0001obtained abs = 1.18366e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.303067; expected ratio = 0.001obtained abs = 153.209; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792440e+05 Mflops = 340.80 -Solve time = 0.00 -Solve flops = 1.655000e+04 Mflops = 359.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.8686; expected ratio = 0.0001obtained abs = 1.17236e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.285676; expected ratio = 0.001obtained abs = 133.188; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796360e+05 Mflops = 342.94 -Solve time = 0.00 -Solve flops = 1.657600e+04 Mflops = 486.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.73658; expected ratio = 0.0001obtained abs = 4.39039e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.268288; expected ratio = 0.001obtained abs = 108.467; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.414159; expected ratio = 0.0001obtained abs = 2.64901e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.169784; expected ratio = 0.001obtained abs = 67.6675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.880160e+05 Mflops = 352.84 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.481004; expected ratio = 0.0001obtained abs = 4.48895e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.157587; expected ratio = 0.001obtained abs = 67.8773; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791240e+05 Mflops = 345.90 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.498354; expected ratio = 0.0001obtained abs = 6.50477e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.182193; expected ratio = 0.001obtained abs = 88.9928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800100e+05 Mflops = 346.82 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 490.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.17346; expected ratio = 0.0001obtained abs = 7.82009e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.211457; expected ratio = 0.001obtained abs = 95.8232; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859500e+05 Mflops = 351.48 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 481.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.649825; expected ratio = 0.0001obtained abs = 3.4725e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.232961; expected ratio = 0.001obtained abs = 91.7968; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.864100e+05 Mflops = 352.35 -Solve time = 0.00 -Solve flops = 1.690800e+04 Mflops = 495.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.515453; expected ratio = 0.0001obtained abs = 4.24678e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125118; expected ratio = 0.001obtained abs = 52.6038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839660e+05 Mflops = 353.79 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 493.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.724536; expected ratio = 0.0001obtained abs = 1.31974e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.269938; expected ratio = 0.001obtained abs = 137.333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.781120e+05 Mflops = 343.95 -Solve time = 0.00 -Solve flops = 1.651600e+04 Mflops = 484.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.46005; expected ratio = 0.0001obtained abs = 1.20745e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.259479; expected ratio = 0.001obtained abs = 121.395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.794640e+05 Mflops = 345.76 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 486.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.689308; expected ratio = 0.0001obtained abs = 4.6436e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189769; expected ratio = 0.001obtained abs = 82.7766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802440e+05 Mflops = 342.08 -Solve time = 0.00 -Solve flops = 1.661000e+04 Mflops = 487.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.631008; expected ratio = 0.0001obtained abs = 3.06448e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.214142; expected ratio = 0.001obtained abs = 83.1065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.873700e+05 Mflops = 352.73 -Solve time = 0.00 -Solve flops = 1.696000e+04 Mflops = 500.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.58659; expected ratio = 0.0001obtained abs = 5.17896e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.14733; expected ratio = 0.001obtained abs = 61.0635; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839660e+05 Mflops = 355.09 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 493.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.71136; expected ratio = 0.0001obtained abs = 1.3112e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.279542; expected ratio = 0.001obtained abs = 142.811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792140e+05 Mflops = 345.44 -Solve time = 0.00 -Solve flops = 1.658000e+04 Mflops = 486.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.63294; expected ratio = 0.0001obtained abs = 1.25059e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.223715; expected ratio = 0.001obtained abs = 105.594; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804360e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 487.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.757055; expected ratio = 0.0001obtained abs = 4.4345e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.177306; expected ratio = 0.001obtained abs = 77.2859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.581256 - Final Residual ratio : 0.000476892 - Residual ratio : 0.000820451 - Slope : -0.0241991 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.579153 - Final Residual ratio : 0.000458467 - Residual ratio : 0.000791615 - Slope : -0.0241123 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.578598 - Final Residual ratio : 0.000447636 - Residual ratio : 0.000773657 - Slope : -0.0240896 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.57828 - Final Residual ratio : 0.000437996 - Residual ratio : 0.000757411 - Slope : -0.0240767 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.661927 - Final Residual ratio : 0.000599758 - Residual ratio : 0.000906078 - Slope : -0.0275553 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.579377 - Final Residual ratio : 0.000457997 - Residual ratio : 0.0007905 - Slope : -0.0241216 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0421 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.577206 - Final Residual ratio : 0.000442828 - Residual ratio : 0.000767192 - Slope : -0.0240318 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.576531 - Final Residual ratio : 0.000447596 - Residual ratio : 0.00077636 - Slope : -0.0240035 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.576171 - Final Residual ratio : 0.00044839 - Residual ratio : 0.000778224 - Slope : -0.0239884 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.658458 - Final Residual ratio : 0.000596519 - Residual ratio : 0.000905933 - Slope : -0.0274109 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839900e+05 Mflops = 344.51 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 478.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.668331; expected ratio = 0.0001obtained abs = 2.69515e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.193453; expected ratio = 0.001obtained abs = 75.156; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843520e+05 Mflops = 354.53 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 493.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.796324; expected ratio = 0.0001obtained abs = 9.15696e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.26496; expected ratio = 0.001obtained abs = 122.09; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.780500e+05 Mflops = 344.46 -Solve time = 0.00 -Solve flops = 1.652400e+04 Mflops = 484.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.738166; expected ratio = 0.0001obtained abs = 6.36382e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.187902; expected ratio = 0.001obtained abs = 87.9241; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 341.70 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 474.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.576164; expected ratio = 0.0001obtained abs = 3.51658e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145921; expected ratio = 0.001obtained abs = 64.624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809460e+05 Mflops = 346.08 -Solve time = 0.00 -Solve flops = 1.666600e+04 Mflops = 488.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.672961; expected ratio = 0.0001obtained abs = 2.8286e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.195439; expected ratio = 0.001obtained abs = 77.2806; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855840e+05 Mflops = 350.16 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 497.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.562032; expected ratio = 0.0001obtained abs = 3.76461e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137286; expected ratio = 0.001obtained abs = 56.9521; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838280e+05 Mflops = 352.71 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.675066; expected ratio = 0.0001obtained abs = 8.71087e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.244984; expected ratio = 0.001obtained abs = 121.336; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.794220e+05 Mflops = 343.63 -Solve time = 0.00 -Solve flops = 1.658800e+04 Mflops = 489.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.43952; expected ratio = 0.0001obtained abs = 8.8335e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.245809; expected ratio = 0.001obtained abs = 112.166; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.794800e+05 Mflops = 345.79 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 490.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.772674; expected ratio = 0.0001obtained abs = 7.87059e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.228691; expected ratio = 0.001obtained abs = 106.421; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.783260e+05 Mflops = 335.71 -Solve time = 0.00 -Solve flops = 1.653000e+04 Mflops = 488.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.48432; expected ratio = 0.0001obtained abs = 8.26353e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.31798; expected ratio = 0.001obtained abs = 129.352; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839600e+05 Mflops = 351.68 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 496.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.854516; expected ratio = 0.0001obtained abs = 1.13445e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.347212; expected ratio = 0.001obtained abs = 173.13; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807400e+05 Mflops = 341.02 -Solve time = 0.00 -Solve flops = 1.663200e+04 Mflops = 491.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.43872; expected ratio = 0.0001obtained abs = 8.91903e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.338559; expected ratio = 0.001obtained abs = 156.23; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838360e+05 Mflops = 350.17 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 483.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.610327; expected ratio = 0.0001obtained abs = 4.37058e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.263782; expected ratio = 0.001obtained abs = 113.422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843260e+05 Mflops = 345.14 -Solve time = 0.00 -Solve flops = 1.681400e+04 Mflops = 496.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.533733; expected ratio = 0.0001obtained abs = 3.28221e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.304265; expected ratio = 0.001obtained abs = 123.209; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855600e+05 Mflops = 354.09 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 495.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.626311; expected ratio = 0.0001obtained abs = 6.02661e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.263769; expected ratio = 0.001obtained abs = 116.656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800040e+05 Mflops = 345.53 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 487.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.585244; expected ratio = 0.0001obtained abs = 6.43323e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.191746; expected ratio = 0.001obtained abs = 91.2579; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807640e+05 Mflops = 345.73 -Solve time = 0.00 -Solve flops = 1.667000e+04 Mflops = 488.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.980859; expected ratio = 0.0001obtained abs = 6.00893e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.153603; expected ratio = 0.001obtained abs = 69.5908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816100e+05 Mflops = 347.98 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.2664; expected ratio = 0.0001obtained abs = 1.54022e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125285; expected ratio = 0.001obtained abs = 52.847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847280e+05 Mflops = 347.14 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 496.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.477635; expected ratio = 0.0001obtained abs = 2.39663e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0961644; expected ratio = 0.001obtained abs = 39.1654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.830900e+05 Mflops = 347.48 -Solve time = 0.00 -Solve flops = 1.676000e+04 Mflops = 478.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.681652; expected ratio = 0.0001obtained abs = 6.868e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.206682; expected ratio = 0.001obtained abs = 96.3873; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.577486 - Final Residual ratio : 0.000452706 - Residual ratio : 0.000783926 - Slope : -0.024043 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.575553 - Final Residual ratio : 0.000432749 - Residual ratio : 0.000751883 - Slope : -0.0239634 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.575192 - Final Residual ratio : 0.000431599 - Residual ratio : 0.000750357 - Slope : -0.0239483 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.575095 - Final Residual ratio : 0.000430176 - Residual ratio : 0.000748009 - Slope : -0.0239443 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.655534 - Final Residual ratio : 0.000584268 - Residual ratio : 0.000891285 - Slope : -0.0272896 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.576658 - Final Residual ratio : 0.000455621 - Residual ratio : 0.000790107 - Slope : -0.0240084 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.57469 - Final Residual ratio : 0.000444132 - Residual ratio : 0.00077282 - Slope : -0.0239269 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.574234 - Final Residual ratio : 0.00045306 - Residual ratio : 0.000788982 - Slope : -0.0239075 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.573997 - Final Residual ratio : 0.000454 - Residual ratio : 0.000790944 - Slope : -0.0238976 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.652559 - Final Residual ratio : 0.000592849 - Residual ratio : 0.000908499 - Slope : -0.0271652 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.780500e+05 Mflops = 343.04 -Solve time = 0.00 -Solve flops = 1.652400e+04 Mflops = 484.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.73006; expected ratio = 0.0001obtained abs = 5.38921e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.17458; expected ratio = 0.001obtained abs = 80.3648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809460e+05 Mflops = 344.04 -Solve time = 0.00 -Solve flops = 1.664600e+04 Mflops = 474.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.495116; expected ratio = 0.0001obtained abs = 3.1041e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.151112; expected ratio = 0.001obtained abs = 63.901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 344.59 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 490.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.325695; expected ratio = 0.0001obtained abs = 1.86243e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125392; expected ratio = 0.001obtained abs = 50.8017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.872420e+05 Mflops = 353.28 -Solve time = 0.00 -Solve flops = 1.695400e+04 Mflops = 497.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.626395; expected ratio = 0.0001obtained abs = 6.47317e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146886; expected ratio = 0.001obtained abs = 64.0815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.786500e+05 Mflops = 344.83 -Solve time = 0.00 -Solve flops = 1.655200e+04 Mflops = 485.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.396475; expected ratio = 0.0001obtained abs = 4.77093e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.153454; expected ratio = 0.001obtained abs = 74.1037; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795040e+05 Mflops = 346.48 -Solve time = 0.00 -Solve flops = 1.659400e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.957179; expected ratio = 0.0001obtained abs = 6.45404e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.158011; expected ratio = 0.001obtained abs = 72.0578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.798680e+05 Mflops = 346.54 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 487.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.00648; expected ratio = 0.0001obtained abs = 4.23077e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.175847; expected ratio = 0.001obtained abs = 72.0877; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.77793; expected ratio = 0.0001obtained abs = 4.25403e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129868; expected ratio = 0.001obtained abs = 51.2688; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.879140e+05 Mflops = 354.55 -Solve time = 0.00 -Solve flops = 1.699200e+04 Mflops = 501.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.470134; expected ratio = 0.0001obtained abs = 4.43322e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164426; expected ratio = 0.001obtained abs = 70.9502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 340.78 -Solve time = 0.00 -Solve flops = 1.660400e+04 Mflops = 473.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.38738; expected ratio = 0.0001obtained abs = 4.1505e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139786; expected ratio = 0.001obtained abs = 65.5424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.797300e+05 Mflops = 346.28 -Solve time = 0.00 -Solve flops = 1.660800e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.592282; expected ratio = 0.0001obtained abs = 4.37823e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0936986; expected ratio = 0.001obtained abs = 43.1172; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813880e+05 Mflops = 342.86 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 492.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.324328; expected ratio = 0.0001obtained abs = 1.96817e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101717; expected ratio = 0.001obtained abs = 44.1702; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835500e+05 Mflops = 348.20 -Solve time = 0.00 -Solve flops = 1.676200e+04 Mflops = 495.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.437892; expected ratio = 0.0001obtained abs = 2.14691e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159161; expected ratio = 0.001obtained abs = 62.7259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845560e+05 Mflops = 350.74 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 482.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.705176; expected ratio = 0.0001obtained abs = 8.12434e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.214981; expected ratio = 0.001obtained abs = 96.6567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.780380e+05 Mflops = 344.44 -Solve time = 0.00 -Solve flops = 1.651600e+04 Mflops = 484.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.415108; expected ratio = 0.0001obtained abs = 4.25287e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.148789; expected ratio = 0.001obtained abs = 70.9943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811200e+05 Mflops = 343.59 -Solve time = 0.00 -Solve flops = 1.665600e+04 Mflops = 491.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.631917; expected ratio = 0.0001obtained abs = 4.31595e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117; expected ratio = 0.001obtained abs = 52.8784; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816100e+05 Mflops = 349.26 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 493.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.457316; expected ratio = 0.0001obtained abs = 2.37805e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159608; expected ratio = 0.001obtained abs = 65.4945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.880880e+05 Mflops = 350.31 -Solve time = 0.00 -Solve flops = 1.697200e+04 Mflops = 484.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.380567; expected ratio = 0.0001obtained abs = 2.30886e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.126117; expected ratio = 0.001obtained abs = 49.3273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.852280e+05 Mflops = 357.53 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 484.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.794156; expected ratio = 0.0001obtained abs = 1.46995e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.35371; expected ratio = 0.001obtained abs = 180.624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.780720e+05 Mflops = 343.24 -Solve time = 0.00 -Solve flops = 1.651400e+04 Mflops = 484.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.68738; expected ratio = 0.0001obtained abs = 1.25458e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.318298; expected ratio = 0.001obtained abs = 150.111; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.575537 - Final Residual ratio : 0.000449992 - Residual ratio : 0.000781865 - Slope : -0.023962 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.573631 - Final Residual ratio : 0.000427015 - Residual ratio : 0.000744407 - Slope : -0.0238835 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.573286 - Final Residual ratio : 0.000424804 - Residual ratio : 0.000740999 - Slope : -0.0238692 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0591 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.573154 - Final Residual ratio : 0.000424577 - Residual ratio : 0.000740774 - Slope : -0.0238637 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.650289 - Final Residual ratio : 0.000571701 - Residual ratio : 0.00087915 - Slope : -0.0270715 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.574807 - Final Residual ratio : 0.00045027 - Residual ratio : 0.000783341 - Slope : -0.0239315 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.572836 - Final Residual ratio : 0.000436122 - Residual ratio : 0.000761337 - Slope : -0.02385 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.572412 - Final Residual ratio : 0.000440549 - Residual ratio : 0.000769635 - Slope : -0.0238321 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.572197 - Final Residual ratio : 0.000442514 - Residual ratio : 0.000773359 - Slope : -0.0238231 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0651 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.647918 - Final Residual ratio : 0.000587425 - Residual ratio : 0.000906635 - Slope : -0.0269721 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.779780e+05 Mflops = 342.27 -Solve time = 0.00 -Solve flops = 1.651200e+04 Mflops = 484.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.478051; expected ratio = 0.0001obtained abs = 3.53122e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.195526; expected ratio = 0.001obtained abs = 88.3426; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805860e+05 Mflops = 341.49 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 487.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.721674; expected ratio = 0.0001obtained abs = 3.53757e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.209685; expected ratio = 0.001obtained abs = 87.4489; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.881480e+05 Mflops = 359.69 -Solve time = 0.00 -Solve flops = 1.702400e+04 Mflops = 485.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.58402; expected ratio = 0.0001obtained abs = 4.05311e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138409; expected ratio = 0.001obtained abs = 56.2918; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.851420e+05 Mflops = 354.59 -Solve time = 0.00 -Solve flops = 1.686400e+04 Mflops = 484.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.564238; expected ratio = 0.0001obtained abs = 6.0021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164914; expected ratio = 0.001obtained abs = 74.7203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.788160e+05 Mflops = 345.94 -Solve time = 0.00 -Solve flops = 1.655400e+04 Mflops = 485.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.499202; expected ratio = 0.0001obtained abs = 5.29581e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108267; expected ratio = 0.001obtained abs = 51.6252; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.794040e+05 Mflops = 345.01 -Solve time = 0.00 -Solve flops = 1.659000e+04 Mflops = 486.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.810987; expected ratio = 0.0001obtained abs = 5.29003e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1337; expected ratio = 0.001obtained abs = 60.6991; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818620e+05 Mflops = 348.46 -Solve time = 0.00 -Solve flops = 1.671800e+04 Mflops = 490.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.420579; expected ratio = 0.0001obtained abs = 2.1348e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144689; expected ratio = 0.001obtained abs = 60.3913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 351.24 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.36779; expected ratio = 0.0001obtained abs = 2.20756e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0686286; expected ratio = 0.001obtained abs = 28.7985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.837740e+05 Mflops = 354.07 -Solve time = 0.00 -Solve flops = 1.679800e+04 Mflops = 496.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.718651; expected ratio = 0.0001obtained abs = 9.82471e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.241315; expected ratio = 0.001obtained abs = 119.741; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804720e+05 Mflops = 347.71 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.37528; expected ratio = 0.0001obtained abs = 8.74226e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.259837; expected ratio = 0.001obtained abs = 118.034; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813420e+05 Mflops = 348.74 -Solve time = 0.00 -Solve flops = 1.669400e+04 Mflops = 493.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.503006; expected ratio = 0.0001obtained abs = 2.9259e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.201277; expected ratio = 0.001obtained abs = 82.54; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.882160e+05 Mflops = 346.70 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 497.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.449542; expected ratio = 0.0001obtained abs = 2.41478e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121141; expected ratio = 0.001obtained abs = 48.5351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843520e+05 Mflops = 354.53 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 480.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.737073; expected ratio = 0.0001obtained abs = 9.01232e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.234308; expected ratio = 0.001obtained abs = 108.636; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.780500e+05 Mflops = 345.10 -Solve time = 0.00 -Solve flops = 1.652400e+04 Mflops = 484.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.60862; expected ratio = 0.0001obtained abs = 5.50084e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170543; expected ratio = 0.001obtained abs = 81.1146; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 345.31 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.535045; expected ratio = 0.0001obtained abs = 3.46064e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.152615; expected ratio = 0.001obtained abs = 67.9211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809780e+05 Mflops = 341.47 -Solve time = 0.00 -Solve flops = 1.666600e+04 Mflops = 492.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.411374; expected ratio = 0.0001obtained abs = 2.11015e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.141088; expected ratio = 0.001obtained abs = 59.2379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813880e+05 Mflops = 348.19 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 489.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.433876; expected ratio = 0.0001obtained abs = 3.06348e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101061; expected ratio = 0.001obtained abs = 42.8278; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.853040e+05 Mflops = 354.41 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 481.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.561221; expected ratio = 0.0001obtained abs = 6.37768e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.211516; expected ratio = 0.001obtained abs = 104.268; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812840e+05 Mflops = 335.11 -Solve time = 0.00 -Solve flops = 1.666400e+04 Mflops = 492.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.36363; expected ratio = 0.0001obtained abs = 7.3095e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.26424; expected ratio = 0.001obtained abs = 117.082; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.871980e+05 Mflops = 352.57 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 496.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.583077; expected ratio = 0.0001obtained abs = 2.63961e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.213046; expected ratio = 0.001obtained abs = 83.3185; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.573817 - Final Residual ratio : 0.000445871 - Residual ratio : 0.000777027 - Slope : -0.0238905 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.571872 - Final Residual ratio : 0.000422346 - Residual ratio : 0.000738532 - Slope : -0.0238104 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.571508 - Final Residual ratio : 0.000416929 - Residual ratio : 0.000729524 - Slope : -0.0237955 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.571354 - Final Residual ratio : 0.000415198 - Residual ratio : 0.00072669 - Slope : -0.0237891 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.645822 - Final Residual ratio : 0.000561239 - Residual ratio : 0.000869029 - Slope : -0.0268859 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0711 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.573056 - Final Residual ratio : 0.000440417 - Residual ratio : 0.00076854 - Slope : -0.023859 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.571085 - Final Residual ratio : 0.000426529 - Residual ratio : 0.000746874 - Slope : -0.0237775 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.570685 - Final Residual ratio : 0.000426551 - Residual ratio : 0.000747435 - Slope : -0.0237608 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.570489 - Final Residual ratio : 0.000426308 - Residual ratio : 0.000747268 - Slope : -0.0237526 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.643639 - Final Residual ratio : 0.000577621 - Residual ratio : 0.000897429 - Slope : -0.0267942 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858660e+05 Mflops = 350.06 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 481.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.483273; expected ratio = 0.0001obtained abs = 3.27925e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106827; expected ratio = 0.001obtained abs = 43.8357; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839660e+05 Mflops = 345.70 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 496.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.699377; expected ratio = 0.0001obtained abs = 1.03725e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.28766; expected ratio = 0.001obtained abs = 145.714; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791960e+05 Mflops = 344.61 -Solve time = 0.00 -Solve flops = 1.657600e+04 Mflops = 486.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.29964; expected ratio = 0.0001obtained abs = 9.27536e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.260264; expected ratio = 0.001obtained abs = 119.965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804700e+05 Mflops = 348.50 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.401858; expected ratio = 0.0001obtained abs = 2.58744e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.162454; expected ratio = 0.001obtained abs = 72.126; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815200e+05 Mflops = 349.08 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 493.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.736769; expected ratio = 0.0001obtained abs = 3.24155e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.195826; expected ratio = 0.001obtained abs = 77.8997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.879140e+05 Mflops = 353.76 -Solve time = 0.00 -Solve flops = 1.699200e+04 Mflops = 501.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.637941; expected ratio = 0.0001obtained abs = 5.54583e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.179989; expected ratio = 0.001obtained abs = 77.509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 346.59 -Solve time = 0.00 -Solve flops = 1.660400e+04 Mflops = 487.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.426884; expected ratio = 0.0001obtained abs = 4.6375e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.176843; expected ratio = 0.001obtained abs = 85.0979; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795040e+05 Mflops = 346.64 -Solve time = 0.00 -Solve flops = 1.659400e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.724422; expected ratio = 0.0001obtained abs = 5.01071e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121758; expected ratio = 0.001obtained abs = 55.7912; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 343.56 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 491.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.407361; expected ratio = 0.0001obtained abs = 2.28931e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.112493; expected ratio = 0.001obtained abs = 49.2087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.852300e+05 Mflops = 349.49 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 494.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.573897; expected ratio = 0.0001obtained abs = 2.46596e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.187876; expected ratio = 0.001obtained abs = 73.5351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842100e+05 Mflops = 354.26 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 493.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.850922; expected ratio = 0.0001obtained abs = 1.37975e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.354822; expected ratio = 0.001obtained abs = 179.301; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.794660e+05 Mflops = 346.40 -Solve time = 0.00 -Solve flops = 1.659000e+04 Mflops = 490.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.0091; expected ratio = 0.0001obtained abs = 1.20626e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.360847; expected ratio = 0.001obtained abs = 167.115; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822600e+05 Mflops = 350.51 -Solve time = 0.00 -Solve flops = 1.681400e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.791996; expected ratio = 0.0001obtained abs = 1.01954e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.299267; expected ratio = 0.001obtained abs = 139.347; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 341.40 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.722646; expected ratio = 0.0001obtained abs = 6.33096e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.384256; expected ratio = 0.001obtained abs = 165.647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.887640e+05 Mflops = 361.03 -Solve time = 0.00 -Solve flops = 1.705600e+04 Mflops = 486.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.498242; expected ratio = 0.0001obtained abs = 5.09797e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.307258; expected ratio = 0.001obtained abs = 137.337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817800e+05 Mflops = 348.78 -Solve time = 0.00 -Solve flops = 1.671200e+04 Mflops = 493.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.313972; expected ratio = 0.0001obtained abs = 3.36164e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.190319; expected ratio = 0.001obtained abs = 86.6248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839000e+05 Mflops = 353.66 -Solve time = 0.00 -Solve flops = 1.682000e+04 Mflops = 493.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.186139; expected ratio = 0.0001obtained abs = 1.97423e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11115; expected ratio = 0.001obtained abs = 52.0585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 346.59 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.302029; expected ratio = 0.0001obtained abs = 2.7178e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0880833; expected ratio = 0.001obtained abs = 41.3199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 346.59 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.298895; expected ratio = 0.0001obtained abs = 2.3151e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0952807; expected ratio = 0.001obtained abs = 43.3979; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795660e+05 Mflops = 347.24 -Solve time = 0.00 -Solve flops = 1.660400e+04 Mflops = 490.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.367045; expected ratio = 0.0001obtained abs = 2.51291e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0941717; expected ratio = 0.001obtained abs = 42.3009; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.572163 - Final Residual ratio : 0.000437604 - Residual ratio : 0.000764824 - Slope : -0.0238219 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.570207 - Final Residual ratio : 0.000416722 - Residual ratio : 0.000730827 - Slope : -0.0237412 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0781 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.569838 - Final Residual ratio : 0.000409915 - Residual ratio : 0.000719354 - Slope : -0.0237262 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.569672 - Final Residual ratio : 0.000405897 - Residual ratio : 0.00071251 - Slope : -0.0237194 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.641554 - Final Residual ratio : 0.00055252 - Residual ratio : 0.000861221 - Slope : -0.0267084 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.571391 - Final Residual ratio : 0.000428273 - Residual ratio : 0.000749528 - Slope : -0.0237901 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.569429 - Final Residual ratio : 0.000415572 - Residual ratio : 0.000729804 - Slope : -0.0237089 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.569047 - Final Residual ratio : 0.000414206 - Residual ratio : 0.000727894 - Slope : -0.023693 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.56886 - Final Residual ratio : 0.000411931 - Residual ratio : 0.000724134 - Slope : -0.0236853 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0851 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.639413 - Final Residual ratio : 0.000565804 - Residual ratio : 0.00088488 - Slope : -0.0266186 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 343.21 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 491.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.468854; expected ratio = 0.0001obtained abs = 2.44333e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127388; expected ratio = 0.001obtained abs = 53.3147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858420e+05 Mflops = 350.64 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 498.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.396861; expected ratio = 0.0001obtained abs = 2.64572e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0835062; expected ratio = 0.001obtained abs = 35.1219; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839660e+05 Mflops = 353.79 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 496.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.690754; expected ratio = 0.0001obtained abs = 9.9911e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.247291; expected ratio = 0.001obtained abs = 124.109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816880e+05 Mflops = 342.80 -Solve time = 0.00 -Solve flops = 1.668600e+04 Mflops = 492.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.29851; expected ratio = 0.0001obtained abs = 8.91636e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.263621; expected ratio = 0.001obtained abs = 123.18; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 345.05 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 494.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.393897; expected ratio = 0.0001obtained abs = 2.70446e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.195041; expected ratio = 0.001obtained abs = 85.6248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813140e+05 Mflops = 342.10 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 492.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.385301; expected ratio = 0.0001obtained abs = 2.17458e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120228; expected ratio = 0.001obtained abs = 50.8779; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861280e+05 Mflops = 351.81 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 481.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.356941; expected ratio = 0.0001obtained abs = 2.69359e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0741221; expected ratio = 0.001obtained abs = 31.6561; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838280e+05 Mflops = 352.87 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.581832; expected ratio = 0.0001obtained abs = 8.08264e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.235628; expected ratio = 0.001obtained abs = 119.234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806820e+05 Mflops = 341.52 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 487.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.41994; expected ratio = 0.0001obtained abs = 9.18193e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.257557; expected ratio = 0.001obtained abs = 118.734; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000681162 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809860e+05 Mflops = 347.42 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 475.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.556781; expected ratio = 0.0001obtained abs = 3.24771e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.211391; expected ratio = 0.001obtained abs = 88.2359; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869620e+05 Mflops = 350.86 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 496.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.421602; expected ratio = 0.0001obtained abs = 3.07197e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113944; expected ratio = 0.001obtained abs = 48.9246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842960e+05 Mflops = 348.35 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 479.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.443737; expected ratio = 0.0001obtained abs = 4.27294e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123219; expected ratio = 0.001obtained abs = 56.1642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.779480e+05 Mflops = 343.47 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 484.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.349846; expected ratio = 0.0001obtained abs = 3.71311e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.112043; expected ratio = 0.001obtained abs = 53.6393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.798320e+05 Mflops = 345.20 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 487.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.998426; expected ratio = 0.0001obtained abs = 5.85126e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.152109; expected ratio = 0.001obtained abs = 67.9015; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817940e+05 Mflops = 344.24 -Solve time = 0.00 -Solve flops = 1.670000e+04 Mflops = 489.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.34805; expected ratio = 0.0001obtained abs = 1.8415e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.132536; expected ratio = 0.001obtained abs = 55.3862; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859800e+05 Mflops = 350.90 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 498.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.353926; expected ratio = 0.0001obtained abs = 2.1251e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0628782; expected ratio = 0.001obtained abs = 25.582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859800e+05 Mflops = 350.90 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.503834; expected ratio = 0.0001obtained abs = 4.79126e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.142747; expected ratio = 0.001obtained abs = 63.1087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.786500e+05 Mflops = 343.56 -Solve time = 0.00 -Solve flops = 1.655200e+04 Mflops = 485.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.394937; expected ratio = 0.0001obtained abs = 4.00525e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127695; expected ratio = 0.001obtained abs = 60.7524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792000e+05 Mflops = 339.33 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 476.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.674959; expected ratio = 0.0001obtained abs = 4.44237e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10457; expected ratio = 0.001obtained abs = 47.8937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.786980e+05 Mflops = 344.29 -Solve time = 0.00 -Solve flops = 1.655400e+04 Mflops = 485.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.00861; expected ratio = 0.0001obtained abs = 4.58926e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164625; expected ratio = 0.001obtained abs = 68.3549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.570558 - Final Residual ratio : 0.000426641 - Residual ratio : 0.000747762 - Slope : -0.0237555 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.568611 - Final Residual ratio : 0.000408982 - Residual ratio : 0.000719264 - Slope : -0.0236751 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.568247 - Final Residual ratio : 0.000567015 - Residual ratio : 0.000997833 - Slope : -0.0246817 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.568118 - Final Residual ratio : 0.00054085 - Residual ratio : 0.000952002 - Slope : -0.0246773 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.637346 - Final Residual ratio : 0.000570924 - Residual ratio : 0.000895783 - Slope : -0.0265323 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.569755 - Final Residual ratio : 0.000398849 - Residual ratio : 0.000700036 - Slope : -0.0237232 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.567816 - Final Residual ratio : 0.000560541 - Residual ratio : 0.000987188 - Slope : -0.0246633 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.56749 - Final Residual ratio : 0.000548436 - Residual ratio : 0.000966424 - Slope : -0.0246496 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.567309 - Final Residual ratio : 0.000536658 - Residual ratio : 0.000945971 - Slope : -0.0246423 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.635152 - Final Residual ratio : 0.000546794 - Residual ratio : 0.000860887 - Slope : -0.0264419 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.0951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.0951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.873080e+05 Mflops = 349.48 -Solve time = 0.00 -Solve flops = 1.696000e+04 Mflops = 483.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.11668; expected ratio = 0.0001obtained abs = 3.74364e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.133819; expected ratio = 0.001obtained abs = 52.8927; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.860380e+05 Mflops = 355.81 -Solve time = 0.00 -Solve flops = 1.691600e+04 Mflops = 496.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.03465; expected ratio = 0.0001obtained abs = 8.69514e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185795; expected ratio = 0.001obtained abs = 82.316; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791880e+05 Mflops = 344.60 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.488283; expected ratio = 0.0001obtained abs = 4.36412e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.126886; expected ratio = 0.001obtained abs = 59.4349; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 332.99 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.807942; expected ratio = 0.0001obtained abs = 4.53578e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107008; expected ratio = 0.001obtained abs = 47.8365; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834160e+05 Mflops = 344.21 -Solve time = 0.00 -Solve flops = 1.674200e+04 Mflops = 477.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.542709; expected ratio = 0.0001obtained abs = 2.25948e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.203021; expected ratio = 0.001obtained abs = 79.3292; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.857440e+05 Mflops = 350.46 -Solve time = 0.00 -Solve flops = 1.686600e+04 Mflops = 494.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.768781; expected ratio = 0.0001obtained abs = 8.97017e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.254127; expected ratio = 0.001obtained abs = 117.481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.784980e+05 Mflops = 344.69 -Solve time = 0.00 -Solve flops = 1.655000e+04 Mflops = 485.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.565796; expected ratio = 0.0001obtained abs = 4.84054e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16805; expected ratio = 0.001obtained abs = 80.7359; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 341.70 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.723971; expected ratio = 0.0001obtained abs = 4.01971e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.150758; expected ratio = 0.001obtained abs = 66.4884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 346.19 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 493.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.394476; expected ratio = 0.0001obtained abs = 1.81492e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.156691; expected ratio = 0.001obtained abs = 62.9747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861280e+05 Mflops = 346.04 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 495.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.603167; expected ratio = 0.0001obtained abs = 5.14051e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.150382; expected ratio = 0.001obtained abs = 66.0055; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.824560e+05 Mflops = 339.82 -Solve time = 0.00 -Solve flops = 1.675800e+04 Mflops = 491.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.359294; expected ratio = 0.0001obtained abs = 3.67908e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.150554; expected ratio = 0.001obtained abs = 72.9584; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800340e+05 Mflops = 345.59 -Solve time = 0.00 -Solve flops = 1.662400e+04 Mflops = 487.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.878483; expected ratio = 0.0001obtained abs = 5.20603e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145934; expected ratio = 0.001obtained abs = 66.0758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 346.19 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 476.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.491962; expected ratio = 0.0001obtained abs = 2.319e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.163147; expected ratio = 0.001obtained abs = 66.1328; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 349.98 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 482.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.35101; expected ratio = 0.0001obtained abs = 1.92049e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0797026; expected ratio = 0.001obtained abs = 32.8425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842160e+05 Mflops = 353.62 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 493.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.762092; expected ratio = 0.0001obtained abs = 1.11114e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.287983; expected ratio = 0.001obtained abs = 145.588; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814640e+05 Mflops = 341.77 -Solve time = 0.00 -Solve flops = 1.667400e+04 Mflops = 492.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.22896; expected ratio = 0.0001obtained abs = 8.82257e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.273943; expected ratio = 0.001obtained abs = 125.945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834380e+05 Mflops = 339.69 -Solve time = 0.00 -Solve flops = 1.677600e+04 Mflops = 478.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.35277; expected ratio = 0.0001obtained abs = 2.54165e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.177154; expected ratio = 0.001obtained abs = 79.0913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.14 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.693553; expected ratio = 0.0001obtained abs = 3.41185e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146818; expected ratio = 0.001obtained abs = 62.2985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861600e+05 Mflops = 349.98 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 482.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.371679; expected ratio = 0.0001obtained abs = 2.62163e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113884; expected ratio = 0.001obtained abs = 49.6732; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.789580e+05 Mflops = 344.16 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.437962; expected ratio = 0.0001obtained abs = 4.24765e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170066; expected ratio = 0.001obtained abs = 83.2294; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.0961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.568955 - Final Residual ratio : 0.00040416 - Residual ratio : 0.000710355 - Slope : -0.0236896 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0971 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.567041 - Final Residual ratio : 0.000555224 - Residual ratio : 0.00097916 - Slope : -0.0246298 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.566737 - Final Residual ratio : 0.000527641 - Residual ratio : 0.000931016 - Slope : -0.0246178 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.0991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.566575 - Final Residual ratio : 0.000551812 - Residual ratio : 0.000973943 - Slope : -0.0246097 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.0991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.633042 - Final Residual ratio : 0.000584326 - Residual ratio : 0.000923045 - Slope : -0.0263524 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.568204 - Final Residual ratio : 0.00056027 - Residual ratio : 0.000986038 - Slope : -0.0246802 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.566347 - Final Residual ratio : 0.000546514 - Residual ratio : 0.000964981 - Slope : -0.0246 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.56599 - Final Residual ratio : 0.000565798 - Residual ratio : 0.000999661 - Slope : -0.0245837 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.565784 - Final Residual ratio : 0.000538196 - Residual ratio : 0.000951239 - Slope : -0.0245759 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.630871 - Final Residual ratio : 0.000509176 - Residual ratio : 0.0008071 - Slope : -0.0262651 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 341.04 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 475.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.834767; expected ratio = 0.0001obtained abs = 5.03239e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.188538; expected ratio = 0.001obtained abs = 84.5308; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812040e+05 Mflops = 348.48 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 489.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.582048; expected ratio = 0.0001obtained abs = 2.72267e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.199251; expected ratio = 0.001obtained abs = 78.5218; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.840120e+05 Mflops = 349.87 -Solve time = 0.00 -Solve flops = 1.678000e+04 Mflops = 492.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.693748; expected ratio = 0.0001obtained abs = 7.94234e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.18779; expected ratio = 0.001obtained abs = 83.0526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802380e+05 Mflops = 348.70 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.29942; expected ratio = 0.0001obtained abs = 3.34622e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.168782; expected ratio = 0.001obtained abs = 82.8715; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.798640e+05 Mflops = 347.97 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 487.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.621486; expected ratio = 0.0001obtained abs = 4.65286e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.133612; expected ratio = 0.001obtained abs = 61.8906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817800e+05 Mflops = 349.58 -Solve time = 0.00 -Solve flops = 1.671200e+04 Mflops = 490.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.456588; expected ratio = 0.0001obtained abs = 2.68104e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144945; expected ratio = 0.001obtained abs = 63.5917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843500e+05 Mflops = 349.87 -Solve time = 0.00 -Solve flops = 1.680200e+04 Mflops = 492.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.405959; expected ratio = 0.0001obtained abs = 2.32805e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19092; expected ratio = 0.001obtained abs = 75.374; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.860440e+05 Mflops = 352.45 -Solve time = 0.00 -Solve flops = 1.691600e+04 Mflops = 482.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.813016; expected ratio = 0.0001obtained abs = 1.6095e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.36007; expected ratio = 0.001obtained abs = 186.364; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 342.89 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 491.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.64736; expected ratio = 0.0001obtained abs = 1.28958e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.310898; expected ratio = 0.001obtained abs = 152.575; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.780860e+05 Mflops = 345.81 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 484.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.899976; expected ratio = 0.0001obtained abs = 1.51522e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.228429; expected ratio = 0.001obtained abs = 101.105; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 348.25 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 489.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.5648; expected ratio = 0.0001obtained abs = 1.71662e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.266232; expected ratio = 0.001obtained abs = 104.815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.899100e+05 Mflops = 359.77 -Solve time = 0.00 -Solve flops = 1.710800e+04 Mflops = 501.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.661143; expected ratio = 0.0001obtained abs = 5.86868e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.204229; expected ratio = 0.001obtained abs = 85.2943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.848700e+05 Mflops = 350.70 -Solve time = 0.00 -Solve flops = 1.683000e+04 Mflops = 493.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.51604; expected ratio = 0.0001obtained abs = 6.50159e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.192354; expected ratio = 0.001obtained abs = 90.2205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.780500e+05 Mflops = 345.74 -Solve time = 0.00 -Solve flops = 1.652400e+04 Mflops = 502.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.490371; expected ratio = 0.0001obtained abs = 4.66935e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106251; expected ratio = 0.001obtained abs = 51.3982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815240e+05 Mflops = 343.73 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 492.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.727408; expected ratio = 0.0001obtained abs = 4.5995e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159468; expected ratio = 0.001obtained abs = 71.2911; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826360e+05 Mflops = 344.59 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 477.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.377774; expected ratio = 0.0001obtained abs = 2.02619e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.163944; expected ratio = 0.001obtained abs = 66.5355; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.857660e+05 Mflops = 352.56 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.432739; expected ratio = 0.0001obtained abs = 3.22933e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0874931; expected ratio = 0.001obtained abs = 36.1384; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.852280e+05 Mflops = 357.53 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 498.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.745613; expected ratio = 0.0001obtained abs = 1.36297e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.311136; expected ratio = 0.001obtained abs = 160.436; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812820e+05 Mflops = 344.67 -Solve time = 0.00 -Solve flops = 1.666400e+04 Mflops = 492.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.17657; expected ratio = 0.0001obtained abs = 1.05333e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.297394; expected ratio = 0.001obtained abs = 141.237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.837060e+05 Mflops = 347.24 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 492.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.475896; expected ratio = 0.0001obtained abs = 3.7444e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.20846; expected ratio = 0.001obtained abs = 95.073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.567425 - Final Residual ratio : 0.000543463 - Residual ratio : 0.00095777 - Slope : -0.024647 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.565579 - Final Residual ratio : 0.000530865 - Residual ratio : 0.000938622 - Slope : -0.0245673 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.565236 - Final Residual ratio : 0.000559312 - Residual ratio : 0.000989518 - Slope : -0.0245512 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.565042 - Final Residual ratio : 0.000525326 - Residual ratio : 0.000929711 - Slope : -0.0245442 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.628723 - Final Residual ratio : 0.000505539 - Residual ratio : 0.000804072 - Slope : -0.0261757 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.566691 - Final Residual ratio : 0.000537014 - Residual ratio : 0.000947631 - Slope : -0.0246154 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.1121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.564869 - Final Residual ratio : 0.000530285 - Residual ratio : 0.000938775 - Slope : -0.0245365 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.564529 - Final Residual ratio : 0.000543548 - Residual ratio : 0.000962834 - Slope : -0.0245211 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.564329 - Final Residual ratio : 0.000520936 - Residual ratio : 0.000923107 - Slope : -0.0245134 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.626552 - Final Residual ratio : 0.000499302 - Residual ratio : 0.000796905 - Slope : -0.0260855 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.853840e+05 Mflops = 349.78 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 481.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.667214; expected ratio = 0.0001obtained abs = 3.44604e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.205562; expected ratio = 0.001obtained abs = 85.9954; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.836600e+05 Mflops = 354.50 -Solve time = 0.00 -Solve flops = 1.679200e+04 Mflops = 495.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.682496; expected ratio = 0.0001obtained abs = 8.59356e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249144; expected ratio = 0.001obtained abs = 119.038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792140e+05 Mflops = 341.36 -Solve time = 0.00 -Solve flops = 1.655800e+04 Mflops = 489.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.62226; expected ratio = 0.0001obtained abs = 5.48659e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.22987; expected ratio = 0.001obtained abs = 110.502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822220e+05 Mflops = 350.43 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 494.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.479076; expected ratio = 0.0001obtained abs = 3.19153e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.210884; expected ratio = 0.001obtained abs = 94.2632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 349.79 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 490.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.466995; expected ratio = 0.0001obtained abs = 2.37592e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172086; expected ratio = 0.001obtained abs = 70.7874; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.879140e+05 Mflops = 354.55 -Solve time = 0.00 -Solve flops = 1.699200e+04 Mflops = 484.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.44723; expected ratio = 0.0001obtained abs = 3.45012e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1194; expected ratio = 0.001obtained abs = 50.9319; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838640e+05 Mflops = 354.24 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.619659; expected ratio = 0.0001obtained abs = 8.35337e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.235197; expected ratio = 0.001obtained abs = 119.295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811240e+05 Mflops = 343.75 -Solve time = 0.00 -Solve flops = 1.665400e+04 Mflops = 488.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.37337; expected ratio = 0.0001obtained abs = 8.78971e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243442; expected ratio = 0.001obtained abs = 113.131; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831820e+05 Mflops = 339.21 -Solve time = 0.00 -Solve flops = 1.680000e+04 Mflops = 479.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.675581; expected ratio = 0.0001obtained abs = 6.79359e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.209939; expected ratio = 0.001obtained abs = 94.5049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806100e+05 Mflops = 346.70 -Solve time = 0.00 -Solve flops = 1.665400e+04 Mflops = 488.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.480796; expected ratio = 0.0001obtained abs = 4.41373e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.184432; expected ratio = 0.001obtained abs = 79.4246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.849320e+05 Mflops = 354.99 -Solve time = 0.00 -Solve flops = 1.685400e+04 Mflops = 494.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.985988; expected ratio = 0.0001obtained abs = 9.23677e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.200898; expected ratio = 0.001obtained abs = 93.3807; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802320e+05 Mflops = 347.24 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.38984; expected ratio = 0.0001obtained abs = 8.52334e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.13843; expected ratio = 0.001obtained abs = 67.6845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.799140e+05 Mflops = 347.43 -Solve time = 0.00 -Solve flops = 1.662000e+04 Mflops = 487.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.984042; expected ratio = 0.0001obtained abs = 7.88453e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.158202; expected ratio = 0.001obtained abs = 71.1244; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855020e+05 Mflops = 354.79 -Solve time = 0.00 -Solve flops = 1.688800e+04 Mflops = 495.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.367627; expected ratio = 0.0001obtained abs = 3.04884e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131984; expected ratio = 0.001obtained abs = 60.5691; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809000e+05 Mflops = 347.89 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 488.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.379247; expected ratio = 0.0001obtained abs = 2.68409e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.12499; expected ratio = 0.001obtained abs = 56.5142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826600e+05 Mflops = 342.63 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.435335; expected ratio = 0.0001obtained abs = 4.20557e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110712; expected ratio = 0.001obtained abs = 50.2454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814440e+05 Mflops = 348.30 -Solve time = 0.00 -Solve flops = 1.670000e+04 Mflops = 493.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.410899; expected ratio = 0.0001obtained abs = 3.39538e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119257; expected ratio = 0.001obtained abs = 55.4617; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804060e+05 Mflops = 347.74 -Solve time = 0.00 -Solve flops = 1.664600e+04 Mflops = 491.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.00601; expected ratio = 0.0001obtained abs = 8.61328e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134633; expected ratio = 0.001obtained abs = 61.9235; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.799680e+05 Mflops = 348.17 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 491.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.7475; expected ratio = 0.0001obtained abs = 7.95444e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.114187; expected ratio = 0.001obtained abs = 53.2885; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.824560e+05 Mflops = 350.88 -Solve time = 0.00 -Solve flops = 1.675800e+04 Mflops = 491.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.849758; expected ratio = 0.0001obtained abs = 7.11479e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121509; expected ratio = 0.001obtained abs = 55.9366; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.65887 - Final Residual ratio : 0.00668226 - Residual ratio : 0.000872486 - Slope : -0.546585 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.5532 - Final Residual ratio : 0.0284756 - Residual ratio : 0.000963534 - Slope : -1.28368 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.38647 - Final Residual ratio : 0.00400437 - Residual ratio : 0.000743412 - Slope : -0.199351 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.79651 - Final Residual ratio : 0.00363698 - Residual ratio : 0.000627443 - Slope : -0.206888 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.80988 - Final Residual ratio : 0.00460476 - Residual ratio : 0.000792575 - Slope : -0.21501 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.38589 - Final Residual ratio : 0.00438113 - Residual ratio : 0.000998915 - Slope : -0.16852 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.4889 - Final Residual ratio : 0.00303584 - Residual ratio : 0.000870142 - Slope : -0.129106 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.81995 - Final Residual ratio : 0.00281407 - Residual ratio : 0.000997916 - Slope : -0.108351 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.37361 - Final Residual ratio : 0.00115904 - Residual ratio : 0.000488302 - Slope : -0.098852 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.10688 - Final Residual ratio : 0.00178952 - Residual ratio : 0.000849369 - Slope : -0.0915258 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810020e+05 Mflops = 344.77 -Solve time = 0.00 -Solve flops = 1.667400e+04 Mflops = 479.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.456306; expected ratio = 0.0001obtained abs = 3.75879e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130131; expected ratio = 0.001obtained abs = 60.7199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 338.81 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.362064; expected ratio = 0.0001obtained abs = 2.91278e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119285; expected ratio = 0.001obtained abs = 54.4194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805780e+05 Mflops = 348.55 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 492.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.338742; expected ratio = 0.0001obtained abs = 2.80053e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125551; expected ratio = 0.001obtained abs = 58.4166; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 345.77 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 491.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.378902; expected ratio = 0.0001obtained abs = 2.83055e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121595; expected ratio = 0.001obtained abs = 55.182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.797760e+05 Mflops = 346.36 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 490.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.329374; expected ratio = 0.0001obtained abs = 2.79419e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0947089; expected ratio = 0.001obtained abs = 43.8795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809820e+05 Mflops = 337.68 -Solve time = 0.00 -Solve flops = 1.667400e+04 Mflops = 475.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.367062; expected ratio = 0.0001obtained abs = 2.71426e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10493; expected ratio = 0.001obtained abs = 47.8471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 342.15 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 508.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.327038; expected ratio = 0.0001obtained abs = 2.82403e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105891; expected ratio = 0.001obtained abs = 49.0548; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 344.51 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 491.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.406827; expected ratio = 0.0001obtained abs = 2.92137e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127678; expected ratio = 0.001obtained abs = 58.2287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866980e+05 Mflops = 352.89 -Solve time = 0.00 -Solve flops = 1.692600e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.330821; expected ratio = 0.0001obtained abs = 2.95924e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139115; expected ratio = 0.001obtained abs = 64.4572; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.821160e+05 Mflops = 343.00 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 493.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.225811; expected ratio = 0.0001obtained abs = 1.9153e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123313; expected ratio = 0.001obtained abs = 57.3237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805780e+05 Mflops = 348.55 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 475.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.227131; expected ratio = 0.0001obtained abs = 1.7099e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100022; expected ratio = 0.001obtained abs = 46.093; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 344.93 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 490.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.152405; expected ratio = 0.0001obtained abs = 1.12975e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0663362; expected ratio = 0.001obtained abs = 30.3266; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805180e+05 Mflops = 347.16 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 492.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.14418; expected ratio = 0.0001obtained abs = 1.10576e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0516932; expected ratio = 0.001obtained abs = 23.6311; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.790640e+05 Mflops = 340.46 -Solve time = 0.00 -Solve flops = 1.657600e+04 Mflops = 486.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0899436; expected ratio = 0.0001obtained abs = 6.68715e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0447623; expected ratio = 0.001obtained abs = 20.4257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.35 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0941697; expected ratio = 0.0001obtained abs = 7.36918e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0424957; expected ratio = 0.001obtained abs = 19.5059; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 345.71 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 487.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.157531; expected ratio = 0.0001obtained abs = 1.1615e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0420091; expected ratio = 0.001obtained abs = 19.2121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800760e+05 Mflops = 347.10 -Solve time = 0.00 -Solve flops = 1.663400e+04 Mflops = 487.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.149466; expected ratio = 0.0001obtained abs = 1.15119e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0398455; expected ratio = 0.001obtained abs = 18.2085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.790640e+05 Mflops = 344.36 -Solve time = 0.00 -Solve flops = 1.657600e+04 Mflops = 486.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.114431; expected ratio = 0.0001obtained abs = 8.45337e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0375588; expected ratio = 0.001obtained abs = 17.1424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.114229; expected ratio = 0.0001obtained abs = 8.92141e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0379785; expected ratio = 0.001obtained abs = 17.4047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 344.93 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 490.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.159261; expected ratio = 0.0001obtained abs = 1.17608e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0386955; expected ratio = 0.001obtained abs = 17.706; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1261 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.2904 - Final Residual ratio : 0.0153897 - Residual ratio : 0.000797792 - Slope : -0.71389 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.2407 - Final Residual ratio : 0.0188476 - Residual ratio : 0.000746717 - Slope : -0.970071 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.74523 - Final Residual ratio : 0.00928695 - Residual ratio : 0.000952974 - Slope : -0.423302 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.36709 - Final Residual ratio : 0.00444836 - Residual ratio : 0.00082882 - Slope : -0.191523 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48311 - Final Residual ratio : 0.00342882 - Residual ratio : 0.00076483 - Slope : -0.154472 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.7843 - Final Residual ratio : 0.00226053 - Residual ratio : 0.000597345 - Slope : -0.135073 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.93112 - Final Residual ratio : 0.00262535 - Residual ratio : 0.000895682 - Slope : -0.104589 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0425 - Final Residual ratio : 0.00146638 - Residual ratio : 0.000717936 - Slope : -0.0703804 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2956 - Final Residual ratio : 0.00127701 - Residual ratio : 0.000985651 - Slope : -0.0539301 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.921224 - Final Residual ratio : 0.000850043 - Residual ratio : 0.000922732 - Slope : -0.035399 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 345.40 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0979053; expected ratio = 0.0001obtained abs = 7.36145e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0389245; expected ratio = 0.001obtained abs = 17.7931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 345.08 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 487.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.119731; expected ratio = 0.0001obtained abs = 8.64698e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0359214; expected ratio = 0.001obtained abs = 16.3921; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 340.32 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.117808; expected ratio = 0.0001obtained abs = 8.90316e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0356693; expected ratio = 0.001obtained abs = 16.294; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 344.45 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 487.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.140029; expected ratio = 0.0001obtained abs = 1.01165e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0357331; expected ratio = 0.001obtained abs = 16.3034; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.135246; expected ratio = 0.0001obtained abs = 1.02169e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0356091; expected ratio = 0.001obtained abs = 16.2564; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811100e+05 Mflops = 346.39 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 489.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0961086; expected ratio = 0.0001obtained abs = 6.95853e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0353863; expected ratio = 0.001obtained abs = 16.1479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.08 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0925094; expected ratio = 0.0001obtained abs = 6.9926e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0353211; expected ratio = 0.001obtained abs = 16.129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 344.45 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 487.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.125751; expected ratio = 0.0001obtained abs = 9.09136e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0353685; expected ratio = 0.001obtained abs = 16.1416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.124053; expected ratio = 0.0001obtained abs = 9.37352e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0352812; expected ratio = 0.001obtained abs = 16.1055; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811100e+05 Mflops = 337.91 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 492.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0963367; expected ratio = 0.0001obtained abs = 6.97713e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0350757; expected ratio = 0.001obtained abs = 16.01; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0924615; expected ratio = 0.0001obtained abs = 6.98773e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0349961; expected ratio = 0.001obtained abs = 15.978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 344.45 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 487.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.102869; expected ratio = 0.0001obtained abs = 7.44353e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0349352; expected ratio = 0.001obtained abs = 15.9476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.08 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0991007; expected ratio = 0.0001obtained abs = 7.4856e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0348127; expected ratio = 0.001obtained abs = 15.8909; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 347.08 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 479.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.095541; expected ratio = 0.0001obtained abs = 6.92205e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0345937; expected ratio = 0.001obtained abs = 15.7925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.35 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0916675; expected ratio = 0.0001obtained abs = 6.92559e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0344896; expected ratio = 0.001obtained abs = 15.7452; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811100e+05 Mflops = 345.76 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 489.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0953752; expected ratio = 0.0001obtained abs = 6.91076e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0343723; expected ratio = 0.001obtained abs = 15.6931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0909963; expected ratio = 0.0001obtained abs = 6.87083e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.03424; expected ratio = 0.001obtained abs = 15.6291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 347.08 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 490.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.094371; expected ratio = 0.0001obtained abs = 6.83968e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0340201; expected ratio = 0.001obtained abs = 15.5322; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0904322; expected ratio = 0.0001obtained abs = 6.82952e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0339001; expected ratio = 0.001obtained abs = 15.4751; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 346.44 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 493.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0939168; expected ratio = 0.0001obtained abs = 6.8075e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0337516; expected ratio = 0.001obtained abs = 15.4108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.842456 - Final Residual ratio : 0.000584799 - Residual ratio : 0.00069416 - Slope : -0.0290301 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.890345 - Final Residual ratio : 0.000701721 - Residual ratio : 0.000788145 - Slope : -0.0306774 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.854138 - Final Residual ratio : 0.00057355 - Residual ratio : 0.000671496 - Slope : -0.0294333 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.728065 - Final Residual ratio : 0.000590294 - Residual ratio : 0.000810771 - Slope : -0.0259812 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.639542 - Final Residual ratio : 0.000624091 - Residual ratio : 0.00097584 - Slope : -0.0255567 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.496119 - Final Residual ratio : 0.000311055 - Residual ratio : 0.000626976 - Slope : -0.0177074 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.5156 - Final Residual ratio : 0.000503158 - Residual ratio : 0.000975869 - Slope : -0.0245284 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.587836 - Final Residual ratio : 0.000499947 - Residual ratio : 0.000850488 - Slope : -0.0391557 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.645229 - Final Residual ratio : 0.00063804 - Residual ratio : 0.000988859 - Slope : -0.0257836 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1451 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.731391 - Final Residual ratio : 0.000561434 - Residual ratio : 0.000767624 - Slope : -0.0270678 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.125673; expected ratio = 0.0001obtained abs = 9.74293e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0351281; expected ratio = 0.001obtained abs = 16.0714; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 344.78 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0944907; expected ratio = 0.0001obtained abs = 7.04983e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0355541; expected ratio = 0.001obtained abs = 16.3225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 351.28 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 480.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0922591; expected ratio = 0.0001obtained abs = 7.17449e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0351042; expected ratio = 0.001obtained abs = 16.1326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 345.71 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 490.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.108898; expected ratio = 0.0001obtained abs = 8.0305e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0365023; expected ratio = 0.001obtained abs = 16.7557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 350.64 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.100326; expected ratio = 0.0001obtained abs = 7.73791e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0368954; expected ratio = 0.001obtained abs = 16.9098; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0957593; expected ratio = 0.0001obtained abs = 7.1151e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.036128; expected ratio = 0.001obtained abs = 16.585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 351.44 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0960096; expected ratio = 0.0001obtained abs = 7.46191e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0362203; expected ratio = 0.001obtained abs = 16.6405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 347.04 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 491.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.1076; expected ratio = 0.0001obtained abs = 7.95307e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0371102; expected ratio = 0.001obtained abs = 17.0444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 351.28 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0997555; expected ratio = 0.0001obtained abs = 7.69988e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0371881; expected ratio = 0.001obtained abs = 17.0503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0979389; expected ratio = 0.0001obtained abs = 7.26856e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0364856; expected ratio = 0.001obtained abs = 16.7482; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 351.28 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0978015; expected ratio = 0.0001obtained abs = 7.60129e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0366689; expected ratio = 0.001obtained abs = 16.8427; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.790640e+05 Mflops = 345.63 -Solve time = 0.00 -Solve flops = 1.657600e+04 Mflops = 486.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.107091; expected ratio = 0.0001obtained abs = 7.92286e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0373737; expected ratio = 0.001obtained abs = 17.168; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 350.64 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0996362; expected ratio = 0.0001obtained abs = 7.69839e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0373993; expected ratio = 0.001obtained abs = 17.1512; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 350.80 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0998315; expected ratio = 0.0001obtained abs = 7.40548e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0368486; expected ratio = 0.001obtained abs = 16.9159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 350.64 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.09911; expected ratio = 0.0001obtained abs = 7.70335e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0370726; expected ratio = 0.001obtained abs = 17.0261; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.790640e+05 Mflops = 346.27 -Solve time = 0.00 -Solve flops = 1.657600e+04 Mflops = 489.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.107018; expected ratio = 0.0001obtained abs = 7.92085e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0376911; expected ratio = 0.001obtained abs = 17.3145; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 351.28 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0998161; expected ratio = 0.0001obtained abs = 7.71847e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0377241; expected ratio = 0.001obtained abs = 17.3024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.35 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.101488; expected ratio = 0.0001obtained abs = 7.5267e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0372804; expected ratio = 0.001obtained abs = 17.1155; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 351.44 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.10034; expected ratio = 0.0001obtained abs = 7.80057e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0375188; expected ratio = 0.001obtained abs = 17.2302; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.790640e+05 Mflops = 345.63 -Solve time = 0.00 -Solve flops = 1.657600e+04 Mflops = 489.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.107655; expected ratio = 0.0001obtained abs = 7.96882e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0381013; expected ratio = 0.001obtained abs = 17.5031; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.654846 - Final Residual ratio : 0.00031404 - Residual ratio : 0.000479564 - Slope : -0.0284579 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.630934 - Final Residual ratio : 0.000560232 - Residual ratio : 0.00088794 - Slope : -0.0233472 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.600921 - Final Residual ratio : 0.000458701 - Residual ratio : 0.00076333 - Slope : -0.0214451 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.575601 - Final Residual ratio : 0.000483605 - Residual ratio : 0.000840173 - Slope : -0.0205399 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.612007 - Final Residual ratio : 0.000578756 - Residual ratio : 0.000945668 - Slope : -0.0226455 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.551575 - Final Residual ratio : 0.000462287 - Residual ratio : 0.000838121 - Slope : -0.0196826 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.0019 - Final Residual ratio : 0.0130809 - Residual ratio : 0.000871955 - Slope : -0.576492 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.91907 - Final Residual ratio : 0.00398502 - Residual ratio : 0.000673251 - Slope : -0.203968 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98856 - Final Residual ratio : 0.00173004 - Residual ratio : 0.000869999 - Slope : -0.0764164 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53313 - Final Residual ratio : 0.00112173 - Residual ratio : 0.000731656 - Slope : -0.0547147 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811100e+05 Mflops = 345.60 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 475.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.111157; expected ratio = 0.0001obtained abs = 8.4482e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0372232; expected ratio = 0.001obtained abs = 16.9824; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811100e+05 Mflops = 346.86 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 492.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.107707; expected ratio = 0.0001obtained abs = 7.77565e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0345268; expected ratio = 0.001obtained abs = 15.6829; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.852220e+05 Mflops = 350.73 -Solve time = 0.00 -Solve flops = 1.685400e+04 Mflops = 497.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.146387; expected ratio = 0.0001obtained abs = 1.0929e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0351045; expected ratio = 0.001obtained abs = 15.9498; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805780e+05 Mflops = 338.73 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 492.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.118688; expected ratio = 0.0001obtained abs = 8.69118e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0334214; expected ratio = 0.001obtained abs = 15.2451; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 349.14 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 476.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.101293; expected ratio = 0.0001obtained abs = 7.59334e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0308866; expected ratio = 0.001obtained abs = 14.0753; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 347.08 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 493.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0700536; expected ratio = 0.0001obtained abs = 5.06252e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0310962; expected ratio = 0.001obtained abs = 14.1307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.862560e+05 Mflops = 346.74 -Solve time = 0.00 -Solve flops = 1.690000e+04 Mflops = 485.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.070225; expected ratio = 0.0001obtained abs = 5.27607e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.031237; expected ratio = 0.001obtained abs = 14.1935; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805780e+05 Mflops = 347.27 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 488.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0797597; expected ratio = 0.0001obtained abs = 5.89293e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0296598; expected ratio = 0.001obtained abs = 13.5426; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 348.51 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 476.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0467742; expected ratio = 0.0001obtained abs = 3.52789e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.027112; expected ratio = 0.001obtained abs = 12.3801; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 348.35 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 476.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.066464; expected ratio = 0.0001obtained abs = 4.82309e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0279654; expected ratio = 0.001obtained abs = 12.738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827680e+05 Mflops = 344.84 -Solve time = 0.00 -Solve flops = 1.674400e+04 Mflops = 491.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0580886; expected ratio = 0.0001obtained abs = 4.3243e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0275559; expected ratio = 0.001obtained abs = 12.5113; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817940e+05 Mflops = 344.40 -Solve time = 0.00 -Solve flops = 1.670000e+04 Mflops = 489.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0560433; expected ratio = 0.0001obtained abs = 4.11355e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0250111; expected ratio = 0.001obtained abs = 11.3942; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 347.87 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 490.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0642811; expected ratio = 0.0001obtained abs = 4.85794e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0243409; expected ratio = 0.001obtained abs = 11.1119; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 343.32 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 490.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0689736; expected ratio = 0.0001obtained abs = 5.03709e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0252331; expected ratio = 0.001obtained abs = 11.5123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 348.51 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 490.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.057193; expected ratio = 0.0001obtained abs = 4.24817e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0245706; expected ratio = 0.001obtained abs = 11.1644; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813520e+05 Mflops = 344.18 -Solve time = 0.00 -Solve flops = 1.667400e+04 Mflops = 489.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0561279; expected ratio = 0.0001obtained abs = 4.10503e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0218652; expected ratio = 0.001obtained abs = 9.94992; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827680e+05 Mflops = 344.84 -Solve time = 0.00 -Solve flops = 1.674400e+04 Mflops = 477.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0564669; expected ratio = 0.0001obtained abs = 4.2451e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0219483; expected ratio = 0.001obtained abs = 10.0049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 347.87 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 490.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0513764; expected ratio = 0.0001obtained abs = 3.77472e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0219629; expected ratio = 0.001obtained abs = 10.0251; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 348.51 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 476.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0461359; expected ratio = 0.0001obtained abs = 3.43037e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0208044; expected ratio = 0.001obtained abs = 9.46684; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 348.51 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 490.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0494523; expected ratio = 0.0001obtained abs = 3.61032e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0191678; expected ratio = 0.001obtained abs = 8.72133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.74693 - Final Residual ratio : 0.00115438 - Residual ratio : 0.000660804 - Slope : -0.0623492 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.99095 - Final Residual ratio : 0.00195042 - Residual ratio : 0.000979646 - Slope : -0.0710356 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0759 - Final Residual ratio : 0.00181962 - Residual ratio : 0.000876543 - Slope : -0.0740743 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.99835 - Final Residual ratio : 0.00142506 - Residual ratio : 0.000713119 - Slope : -0.0713187 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81189 - Final Residual ratio : 0.00154606 - Residual ratio : 0.000853285 - Slope : -0.0670497 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.8631 - Final Residual ratio : 0.0262378 - Residual ratio : 0.000976724 - Slope : -1.1182 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.72543 - Final Residual ratio : 0.00608408 - Residual ratio : 0.000904637 - Slope : -0.258437 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.62255 - Final Residual ratio : 0.00258557 - Residual ratio : 0.000985898 - Slope : -0.163748 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.22213 - Final Residual ratio : 0.00201442 - Residual ratio : 0.000906527 - Slope : -0.138757 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.34837 - Final Residual ratio : 0.00206844 - Residual ratio : 0.000880796 - Slope : -0.146644 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 349.63 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.143744; expected ratio = 0.0001obtained abs = 1.15344e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0241091; expected ratio = 0.001obtained abs = 11.0433; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.77 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0417964; expected ratio = 0.0001obtained abs = 3.35773e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0250095; expected ratio = 0.001obtained abs = 11.5771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 480.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.11669; expected ratio = 0.0001obtained abs = 9.06831e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0169657; expected ratio = 0.001obtained abs = 7.8446; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 347.08 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 493.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0608871; expected ratio = 0.0001obtained abs = 4.55636e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0209168; expected ratio = 0.001obtained abs = 9.60075; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.127818; expected ratio = 0.0001obtained abs = 1.00846e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0202887; expected ratio = 0.001obtained abs = 9.29778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 344.96 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 495.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0361426; expected ratio = 0.0001obtained abs = 2.87405e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.019981; expected ratio = 0.001obtained abs = 9.22158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.27946; expected ratio = 0.0001obtained abs = 2.16025e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0163654; expected ratio = 0.001obtained abs = 7.5743; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811100e+05 Mflops = 347.02 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 489.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.144386; expected ratio = 0.0001obtained abs = 1.10212e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0190441; expected ratio = 0.001obtained abs = 8.77963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.047677; expected ratio = 0.0001obtained abs = 3.69736e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0190471; expected ratio = 0.001obtained abs = 8.74938; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.77 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.413379; expected ratio = 0.0001obtained abs = 3.28752e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0166781; expected ratio = 0.001obtained abs = 7.68305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.206597; expected ratio = 0.0001obtained abs = 1.60666e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0165835; expected ratio = 0.001obtained abs = 7.66227; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815520e+05 Mflops = 341.93 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 476.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0519634; expected ratio = 0.0001obtained abs = 3.95287e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018069; expected ratio = 0.001obtained abs = 8.33583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.149926; expected ratio = 0.0001obtained abs = 1.14255e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0181459; expected ratio = 0.001obtained abs = 8.34448; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.35 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0537495; expected ratio = 0.0001obtained abs = 4.09542e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162369; expected ratio = 0.001obtained abs = 7.47761; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0630801; expected ratio = 0.0001obtained abs = 4.94856e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0166291; expected ratio = 0.001obtained abs = 7.67579; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805180e+05 Mflops = 346.52 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 475.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0474181; expected ratio = 0.0001obtained abs = 3.65604e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0173708; expected ratio = 0.001obtained abs = 8.01949; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0420233; expected ratio = 0.0001obtained abs = 3.28117e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0171307; expected ratio = 0.001obtained abs = 7.89154; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.35 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0430655; expected ratio = 0.0001obtained abs = 3.30806e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161986; expected ratio = 0.001obtained abs = 7.46596; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0441028; expected ratio = 0.0001obtained abs = 3.45402e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0163787; expected ratio = 0.001obtained abs = 7.55289; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0465169; expected ratio = 0.0001obtained abs = 3.58363e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0166064; expected ratio = 0.001obtained abs = 7.66229; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.3443 - Final Residual ratio : 0.00216606 - Residual ratio : 0.000923972 - Slope : -0.146383 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.25071 - Final Residual ratio : 0.00216892 - Residual ratio : 0.000963664 - Slope : -0.124919 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.9037 - Final Residual ratio : 0.0321427 - Residual ratio : 0.00076706 - Slope : -1.5508 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8687 - Final Residual ratio : 0.0086856 - Residual ratio : 0.000674942 - Slope : -0.443447 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.46916 - Final Residual ratio : 0.00331838 - Residual ratio : 0.000742507 - Slope : -0.186077 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.97115 - Final Residual ratio : 0.00386813 - Residual ratio : 0.000974057 - Slope : -0.141689 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1721 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.62701 - Final Residual ratio : 0.00264147 - Residual ratio : 0.000728277 - Slope : -0.124978 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.2277 - Final Residual ratio : 0.00219774 - Residual ratio : 0.0006809 - Slope : -0.111224 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1741 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.76829 - Final Residual ratio : 0.00252764 - Residual ratio : 0.000913067 - Slope : -0.0987774 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.30588 - Final Residual ratio : 0.00173836 - Residual ratio : 0.000753881 - Slope : -0.0822909 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811100e+05 Mflops = 344.97 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 475.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0598543; expected ratio = 0.0001obtained abs = 4.66507e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162427; expected ratio = 0.001obtained abs = 7.46504; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800760e+05 Mflops = 346.31 -Solve time = 0.00 -Solve flops = 1.663400e+04 Mflops = 487.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0445873; expected ratio = 0.0001obtained abs = 3.4063e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0147181; expected ratio = 0.001obtained abs = 6.74936; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 345.06 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0489; expected ratio = 0.0001obtained abs = 3.84995e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0155579; expected ratio = 0.001obtained abs = 7.14287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0363956; expected ratio = 0.0001obtained abs = 2.82853e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.015555; expected ratio = 0.001obtained abs = 7.16174; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800760e+05 Mflops = 347.10 -Solve time = 0.00 -Solve flops = 1.663400e+04 Mflops = 491.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0323514; expected ratio = 0.0001obtained abs = 2.5364e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0141548; expected ratio = 0.001obtained abs = 6.51075; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800760e+05 Mflops = 345.67 -Solve time = 0.00 -Solve flops = 1.663400e+04 Mflops = 487.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0402277; expected ratio = 0.0001obtained abs = 3.0894e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0144266; expected ratio = 0.001obtained abs = 6.62695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 480.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.039153; expected ratio = 0.0001obtained abs = 3.06569e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0146756; expected ratio = 0.001obtained abs = 6.7381; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0335446; expected ratio = 0.0001obtained abs = 2.59889e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142514; expected ratio = 0.001obtained abs = 6.55501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0345659; expected ratio = 0.0001obtained abs = 2.71597e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136626; expected ratio = 0.001obtained abs = 6.2848; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800760e+05 Mflops = 345.04 -Solve time = 0.00 -Solve flops = 1.663400e+04 Mflops = 487.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0388751; expected ratio = 0.0001obtained abs = 2.99614e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0139926; expected ratio = 0.001obtained abs = 6.43365; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0355206; expected ratio = 0.0001obtained abs = 2.77876e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0139872; expected ratio = 0.001obtained abs = 6.4247; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0331122; expected ratio = 0.0001obtained abs = 2.56088e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0134503; expected ratio = 0.001obtained abs = 6.18429; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 340.78 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0345876; expected ratio = 0.0001obtained abs = 2.71649e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0132505; expected ratio = 0.001obtained abs = 6.0936; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800760e+05 Mflops = 346.31 -Solve time = 0.00 -Solve flops = 1.663400e+04 Mflops = 474.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0365971; expected ratio = 0.0001obtained abs = 2.82497e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.013425; expected ratio = 0.001obtained abs = 6.17404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805180e+05 Mflops = 347.16 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 488.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0332344; expected ratio = 0.0001obtained abs = 2.59926e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0133015; expected ratio = 0.001obtained abs = 6.1109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.032175; expected ratio = 0.0001obtained abs = 2.48712e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0128107; expected ratio = 0.001obtained abs = 5.88953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 342.77 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0334925; expected ratio = 0.0001obtained abs = 2.62867e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0127049; expected ratio = 0.001obtained abs = 5.84172; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800760e+05 Mflops = 345.67 -Solve time = 0.00 -Solve flops = 1.663400e+04 Mflops = 487.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0343313; expected ratio = 0.0001obtained abs = 2.6525e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0127838; expected ratio = 0.001obtained abs = 5.87953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805180e+05 Mflops = 346.52 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 488.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0313254; expected ratio = 0.0001obtained abs = 2.44972e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0126032; expected ratio = 0.001obtained abs = 5.79087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805180e+05 Mflops = 338.62 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 488.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.030923; expected ratio = 0.0001obtained abs = 2.39009e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0121793; expected ratio = 0.001obtained abs = 5.59908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.89427 - Final Residual ratio : 0.000925646 - Residual ratio : 0.000488655 - Slope : -0.0676195 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.60145 - Final Residual ratio : 0.00154177 - Residual ratio : 0.000962732 - Slope : -0.0695612 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42225 - Final Residual ratio : 0.00129481 - Residual ratio : 0.0009104 - Slope : -0.101496 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31234 - Final Residual ratio : 0.00107048 - Residual ratio : 0.000815706 - Slope : -0.0524508 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.23206 - Final Residual ratio : 0.00103735 - Residual ratio : 0.000841968 - Slope : -0.0535226 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12063 - Final Residual ratio : 0.00100178 - Residual ratio : 0.00089394 - Slope : -0.0658607 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01956 - Final Residual ratio : 0.0008452 - Residual ratio : 0.000828989 - Slope : -0.0391812 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.920877 - Final Residual ratio : 0.000822519 - Residual ratio : 0.000893191 - Slope : -0.0353867 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.83484 - Final Residual ratio : 0.000530381 - Residual ratio : 0.000635308 - Slope : -0.0297968 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.777374 - Final Residual ratio : 0.000509831 - Residual ratio : 0.000655837 - Slope : -0.0277451 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 480.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0700782; expected ratio = 0.0001obtained abs = 5.53591e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.013271; expected ratio = 0.001obtained abs = 6.11376; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0619515; expected ratio = 0.0001obtained abs = 4.84239e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0131951; expected ratio = 0.001obtained abs = 6.0923; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805180e+05 Mflops = 340.60 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 488.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0409562; expected ratio = 0.0001obtained abs = 3.2357e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122166; expected ratio = 0.001obtained abs = 5.63416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805180e+05 Mflops = 348.59 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 488.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0383142; expected ratio = 0.0001obtained abs = 2.97479e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0121933; expected ratio = 0.001obtained abs = 5.61893; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0367333; expected ratio = 0.0001obtained abs = 2.89762e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0126035; expected ratio = 0.001obtained abs = 5.80838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0345552; expected ratio = 0.0001obtained abs = 2.69647e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0125276; expected ratio = 0.001obtained abs = 5.78004; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 350.64 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0321987; expected ratio = 0.0001obtained abs = 2.54318e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.012146; expected ratio = 0.001obtained abs = 5.60156; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805180e+05 Mflops = 343.22 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 475.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0331508; expected ratio = 0.0001obtained abs = 2.58079e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.012193; expected ratio = 0.001obtained abs = 5.62263; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0322193; expected ratio = 0.0001obtained abs = 2.54176e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.012273; expected ratio = 0.001obtained abs = 5.65743; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0317015; expected ratio = 0.0001obtained abs = 2.47162e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0121251; expected ratio = 0.001obtained abs = 5.59273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 350.64 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 480.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0311449; expected ratio = 0.0001obtained abs = 2.4586e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119714; expected ratio = 0.001obtained abs = 5.52009; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.35 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.031704; expected ratio = 0.0001obtained abs = 2.47036e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119413; expected ratio = 0.001obtained abs = 5.50745; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0309775; expected ratio = 0.0001obtained abs = 2.44395e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119027; expected ratio = 0.001obtained abs = 5.48743; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 480.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0309234; expected ratio = 0.0001obtained abs = 2.41055e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0117765; expected ratio = 0.001obtained abs = 5.43161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 346.03 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0303715; expected ratio = 0.0001obtained abs = 2.39657e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116772; expected ratio = 0.001obtained abs = 5.38399; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.19 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0306279; expected ratio = 0.0001obtained abs = 2.38731e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116028; expected ratio = 0.001obtained abs = 5.35144; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0299778; expected ratio = 0.0001obtained abs = 2.36484e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115306; expected ratio = 0.001obtained abs = 5.3161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0300507; expected ratio = 0.0001obtained abs = 2.34267e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0114227; expected ratio = 0.001obtained abs = 5.26835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0294846; expected ratio = 0.0001obtained abs = 2.32591e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0113364; expected ratio = 0.001obtained abs = 5.2267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.99 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0296366; expected ratio = 0.0001obtained abs = 2.31049e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112478; expected ratio = 0.001obtained abs = 5.18766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.71322 - Final Residual ratio : 0.000431646 - Residual ratio : 0.000605207 - Slope : -0.0254567 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.681064 - Final Residual ratio : 0.000437514 - Residual ratio : 0.000642399 - Slope : -0.0243081 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.662083 - Final Residual ratio : 0.000468513 - Residual ratio : 0.000707634 - Slope : -0.0245043 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.655559 - Final Residual ratio : 0.000546519 - Residual ratio : 0.000833669 - Slope : -0.0284788 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.667853 - Final Residual ratio : 0.00061335 - Residual ratio : 0.000918392 - Slope : -0.025663 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.658872 - Final Residual ratio : 0.000445569 - Residual ratio : 0.00067626 - Slope : -0.0235152 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.662978 - Final Residual ratio : 0.000472028 - Residual ratio : 0.000711981 - Slope : -0.0236609 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.660553 - Final Residual ratio : 0.00047745 - Residual ratio : 0.000722803 - Slope : -0.0235741 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.653184 - Final Residual ratio : 0.000551981 - Residual ratio : 0.000845063 - Slope : -0.0241716 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.651715 - Final Residual ratio : 0.000612156 - Residual ratio : 0.0009393 - Slope : -0.0271293 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.1951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.1951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 347.62 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 515.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.131133; expected ratio = 0.0001obtained abs = 1.08824e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0123213; expected ratio = 0.001obtained abs = 5.69345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 345.06 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.101378; expected ratio = 0.0001obtained abs = 8.19741e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122657; expected ratio = 0.001obtained abs = 5.68531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.028753; expected ratio = 0.0001obtained abs = 2.31988e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106012; expected ratio = 0.001obtained abs = 4.91372; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0259632; expected ratio = 0.0001obtained abs = 2.06169e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0111569; expected ratio = 0.001obtained abs = 5.16565; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 345.68 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 481.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0425178; expected ratio = 0.0001obtained abs = 3.44536e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0114756; expected ratio = 0.001obtained abs = 5.31031; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.08 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0354142; expected ratio = 0.0001obtained abs = 2.83112e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112005; expected ratio = 0.001obtained abs = 5.18925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 340.17 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0242991; expected ratio = 0.0001obtained abs = 1.96141e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01088; expected ratio = 0.001obtained abs = 5.03981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0287545; expected ratio = 0.0001obtained abs = 2.28893e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0110433; expected ratio = 0.001obtained abs = 5.11499; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0303733; expected ratio = 0.0001obtained abs = 2.45194e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01112; expected ratio = 0.001obtained abs = 5.14771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.35 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.028206; expected ratio = 0.0001obtained abs = 2.25034e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0109332; expected ratio = 0.001obtained abs = 5.06457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0268079; expected ratio = 0.0001obtained abs = 2.16403e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0107979; expected ratio = 0.001obtained abs = 5.00049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 480.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0283923; expected ratio = 0.0001obtained abs = 2.26239e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0108033; expected ratio = 0.001obtained abs = 5.00421; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0280907; expected ratio = 0.0001obtained abs = 2.26676e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0107747; expected ratio = 0.001obtained abs = 4.98864; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 349.19 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.027477; expected ratio = 0.0001obtained abs = 2.19109e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106474; expected ratio = 0.001obtained abs = 4.93202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0269239; expected ratio = 0.0001obtained abs = 2.17291e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010564; expected ratio = 0.001obtained abs = 4.89172; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0275419; expected ratio = 0.0001obtained abs = 2.19556e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105175; expected ratio = 0.001obtained abs = 4.87188; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.72 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0269647; expected ratio = 0.0001obtained abs = 2.17556e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010462; expected ratio = 0.001obtained abs = 4.8441; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.29 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0268725; expected ratio = 0.0001obtained abs = 2.14277e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103685; expected ratio = 0.001obtained abs = 4.80279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0264355; expected ratio = 0.0001obtained abs = 2.13296e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103027; expected ratio = 0.001obtained abs = 4.77055; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0267243; expected ratio = 0.0001obtained abs = 2.13086e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102403; expected ratio = 0.001obtained abs = 4.74346; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.1961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.628299 - Final Residual ratio : 0.000566988 - Residual ratio : 0.000902418 - Slope : -0.0272927 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.619111 - Final Residual ratio : 0.000541992 - Residual ratio : 0.000875435 - Slope : -0.0268943 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.610348 - Final Residual ratio : 0.000483952 - Residual ratio : 0.000792912 - Slope : -0.0265158 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.1991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.604406 - Final Residual ratio : 0.000513484 - Residual ratio : 0.000849568 - Slope : -0.0262562 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.1991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.609469 - Final Residual ratio : 0.00046713 - Residual ratio : 0.000766454 - Slope : -0.0264783 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.59864 - Final Residual ratio : 0.000534662 - Residual ratio : 0.000893128 - Slope : -0.0249211 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.600897 - Final Residual ratio : 0.000597052 - Residual ratio : 0.000993602 - Slope : -0.024012 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.601714 - Final Residual ratio : 0.000480074 - Residual ratio : 0.000797843 - Slope : -0.0222679 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.602047 - Final Residual ratio : 0.000493653 - Residual ratio : 0.000819958 - Slope : -0.0222797 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.608765 - Final Residual ratio : 0.000549311 - Residual ratio : 0.000902337 - Slope : -0.0233929 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 349.01 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.086456; expected ratio = 0.0001obtained abs = 7.09142e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0110744; expected ratio = 0.001obtained abs = 5.13806; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.018636; expected ratio = 0.0001obtained abs = 1.51948e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0108681; expected ratio = 0.001obtained abs = 5.05463; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 339.87 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 491.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0886806; expected ratio = 0.0001obtained abs = 7.24671e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00977935; expected ratio = 0.001obtained abs = 4.54795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.08 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 371.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0437603; expected ratio = 0.0001obtained abs = 3.53031e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103736; expected ratio = 0.001obtained abs = 4.8196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0604456; expected ratio = 0.0001obtained abs = 4.93968e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0107501; expected ratio = 0.001obtained abs = 4.99183; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 346.36 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0231504; expected ratio = 0.0001obtained abs = 1.88271e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010535; expected ratio = 0.001obtained abs = 4.89797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 346.36 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.017577; expected ratio = 0.0001obtained abs = 1.43938e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102581; expected ratio = 0.001obtained abs = 4.76882; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 345.68 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 491.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0871876; expected ratio = 0.0001obtained abs = 7.03112e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105208; expected ratio = 0.001obtained abs = 4.89061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0935448; expected ratio = 0.0001obtained abs = 7.64883e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106627; expected ratio = 0.001obtained abs = 4.9529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 346.36 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.026658; expected ratio = 0.0001obtained abs = 2.16593e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0104487; expected ratio = 0.001obtained abs = 4.85682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 344.96 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0194326; expected ratio = 0.0001obtained abs = 1.58996e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01037; expected ratio = 0.001obtained abs = 4.81975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 345.06 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0830998; expected ratio = 0.0001obtained abs = 6.71051e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0104911; expected ratio = 0.001obtained abs = 4.87738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 345.73 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0879363; expected ratio = 0.0001obtained abs = 7.18791e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0104772; expected ratio = 0.001obtained abs = 4.8675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 345.68 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 495.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.050265; expected ratio = 0.0001obtained abs = 4.07563e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102972; expected ratio = 0.001obtained abs = 4.78611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 345.73 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0483989; expected ratio = 0.0001obtained abs = 3.95826e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102874; expected ratio = 0.001obtained abs = 4.78045; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 345.06 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.080903; expected ratio = 0.0001obtained abs = 6.53959e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103227; expected ratio = 0.001obtained abs = 4.79885; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 345.73 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0811125; expected ratio = 0.0001obtained abs = 6.63154e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102651; expected ratio = 0.001obtained abs = 4.76939; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 345.68 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 491.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.066956; expected ratio = 0.0001obtained abs = 5.41831e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0101655; expected ratio = 0.001obtained abs = 4.72512; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 345.73 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0656495; expected ratio = 0.0001obtained abs = 5.36817e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0101545; expected ratio = 0.001obtained abs = 4.71836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832100e+05 Mflops = 345.68 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 495.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0760834; expected ratio = 0.0001obtained abs = 6.15279e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0101434; expected ratio = 0.001obtained abs = 4.71533; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.598232 - Final Residual ratio : 0.000462494 - Residual ratio : 0.000773101 - Slope : -0.0221396 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.597774 - Final Residual ratio : 0.000487608 - Residual ratio : 0.000815706 - Slope : -0.0221217 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.595223 - Final Residual ratio : 0.000534167 - Residual ratio : 0.000897423 - Slope : -0.0228727 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.592824 - Final Residual ratio : 0.000562332 - Residual ratio : 0.000948564 - Slope : -0.0236905 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.597262 - Final Residual ratio : 0.000524403 - Residual ratio : 0.000878013 - Slope : -0.024864 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.587995 - Final Residual ratio : 0.000541896 - Residual ratio : 0.000921601 - Slope : -0.0234981 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.588806 - Final Residual ratio : 0.000576236 - Residual ratio : 0.000978651 - Slope : -0.0235292 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.2131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.588288 - Final Residual ratio : 0.000516296 - Residual ratio : 0.000877624 - Slope : -0.0226066 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.587912 - Final Residual ratio : 0.000544672 - Residual ratio : 0.000926452 - Slope : -0.022591 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.0199 - Final Residual ratio : 0.0197507 - Residual ratio : 0.000657918 - Slope : -1.36364 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835700e+05 Mflops = 342.50 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0589172; expected ratio = 0.0001obtained abs = 4.90175e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100791; expected ratio = 0.001obtained abs = 4.68616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.13 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0175174; expected ratio = 0.0001obtained abs = 1.44847e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103696; expected ratio = 0.001obtained abs = 4.82776; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.61 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 431.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0190519; expected ratio = 0.0001obtained abs = 1.58436e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00986942; expected ratio = 0.001obtained abs = 4.59318; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0346855; expected ratio = 0.0001obtained abs = 2.83782e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00997994; expected ratio = 0.001obtained abs = 4.64412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.77 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 477.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0350925; expected ratio = 0.0001obtained abs = 2.91588e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0101143; expected ratio = 0.001obtained abs = 4.70409; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.61 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 494.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0210112; expected ratio = 0.0001obtained abs = 1.73439e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00997698; expected ratio = 0.001obtained abs = 4.64338; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 349.41 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 477.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0216613; expected ratio = 0.0001obtained abs = 1.80161e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00987493; expected ratio = 0.001obtained abs = 4.59502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.08 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0287846; expected ratio = 0.0001obtained abs = 2.36307e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00997711; expected ratio = 0.001obtained abs = 4.64333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.77 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0286675; expected ratio = 0.0001obtained abs = 2.3824e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100217; expected ratio = 0.001obtained abs = 4.66169; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.61 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 494.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0217737; expected ratio = 0.0001obtained abs = 1.79637e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00994153; expected ratio = 0.001obtained abs = 4.62645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 340.84 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 477.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.022118; expected ratio = 0.0001obtained abs = 1.83944e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00995278; expected ratio = 0.001obtained abs = 4.63091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.025501; expected ratio = 0.0001obtained abs = 2.09821e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100494; expected ratio = 0.001obtained abs = 4.67711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 347.34 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 494.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0252941; expected ratio = 0.0001obtained abs = 2.10221e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100763; expected ratio = 0.001obtained abs = 4.68738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 347.97 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0221484; expected ratio = 0.0001obtained abs = 1.82696e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100398; expected ratio = 0.001obtained abs = 4.67208; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 347.97 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 481.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0223907; expected ratio = 0.0001obtained abs = 1.86204e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100915; expected ratio = 0.001obtained abs = 4.69531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.29 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0247055; expected ratio = 0.0001obtained abs = 2.03446e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0101822; expected ratio = 0.001obtained abs = 4.73888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.61 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0245342; expected ratio = 0.0001obtained abs = 2.03923e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102061; expected ratio = 0.001obtained abs = 4.74793; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 340.23 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0225004; expected ratio = 0.0001obtained abs = 1.85584e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010192; expected ratio = 0.001obtained abs = 4.74292; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823540e+05 Mflops = 348.61 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0226951; expected ratio = 0.0001obtained abs = 1.88738e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102564; expected ratio = 0.001obtained abs = 4.77197; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.92 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0249379; expected ratio = 0.0001obtained abs = 2.05358e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103417; expected ratio = 0.001obtained abs = 4.81312; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.32764 - Final Residual ratio : 0.00805631 - Residual ratio : 0.000863703 - Slope : -0.372783 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.75464 - Final Residual ratio : 0.00237197 - Residual ratio : 0.000861082 - Slope : -0.172017 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.52209 - Final Residual ratio : 0.00147932 - Residual ratio : 0.000586547 - Slope : -0.109592 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.33054 - Final Residual ratio : 0.00230071 - Residual ratio : 0.000987201 - Slope : -0.101228 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.26629 - Final Residual ratio : 0.00189934 - Residual ratio : 0.000838084 - Slope : -0.0905757 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2211 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67203 - Final Residual ratio : 0.00142691 - Residual ratio : 0.000853402 - Slope : -0.0642539 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30403 - Final Residual ratio : 0.000998891 - Residual ratio : 0.000766004 - Slope : -0.0482604 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04968 - Final Residual ratio : 0.00054744 - Residual ratio : 0.000521531 - Slope : -0.037469 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.919225 - Final Residual ratio : 0.000865671 - Residual ratio : 0.000941739 - Slope : -0.0340133 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1591 - Final Residual ratio : 0.00112889 - Residual ratio : 0.000973939 - Slope : -0.0482487 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 338.91 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0678881; expected ratio = 0.0001obtained abs = 5.83266e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118923; expected ratio = 0.001obtained abs = 5.54755; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.21 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0184531; expected ratio = 0.0001obtained abs = 1.57562e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116039; expected ratio = 0.001obtained abs = 5.42939; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0174353; expected ratio = 0.0001obtained abs = 1.49947e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103099; expected ratio = 0.001obtained abs = 4.82552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0239152; expected ratio = 0.0001obtained abs = 2.02564e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112131; expected ratio = 0.001obtained abs = 5.24081; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0203549; expected ratio = 0.0001obtained abs = 1.74052e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116131; expected ratio = 0.001obtained abs = 5.42524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.21 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0179875; expected ratio = 0.0001obtained abs = 1.53191e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0114604; expected ratio = 0.001obtained abs = 5.36067; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.37 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0184111; expected ratio = 0.0001obtained abs = 1.57918e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0113015; expected ratio = 0.001obtained abs = 5.28611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 345.02 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0204333; expected ratio = 0.0001obtained abs = 1.7356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116317; expected ratio = 0.001obtained abs = 5.43915; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.85 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0191614; expected ratio = 0.0001obtained abs = 1.63942e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.011749; expected ratio = 0.001obtained abs = 5.49076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.37 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0183208; expected ratio = 0.0001obtained abs = 1.55854e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115523; expected ratio = 0.001obtained abs = 5.40275; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.21 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.01871; expected ratio = 0.0001obtained abs = 1.60357e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01144; expected ratio = 0.001obtained abs = 5.34922; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.21 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0194076; expected ratio = 0.0001obtained abs = 1.64961e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0114925; expected ratio = 0.001obtained abs = 5.37463; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 355.01 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0187032; expected ratio = 0.0001obtained abs = 1.6012e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0114682; expected ratio = 0.001obtained abs = 5.36054; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.21 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0184773; expected ratio = 0.0001obtained abs = 1.5711e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0113262; expected ratio = 0.001obtained abs = 5.29677; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 355.01 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0186045; expected ratio = 0.0001obtained abs = 1.59397e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112613; expected ratio = 0.001obtained abs = 5.26493; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.37 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0188558; expected ratio = 0.0001obtained abs = 1.60301e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112533; expected ratio = 0.001obtained abs = 5.26288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.37 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0184294; expected ratio = 0.0001obtained abs = 1.57816e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112193; expected ratio = 0.001obtained abs = 5.24462; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.85 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0184326; expected ratio = 0.0001obtained abs = 1.56714e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0111433; expected ratio = 0.001obtained abs = 5.21124; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.37 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0183876; expected ratio = 0.0001obtained abs = 1.57504e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0111127; expected ratio = 0.001obtained abs = 5.19517; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0185056; expected ratio = 0.0001obtained abs = 1.57339e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0110939; expected ratio = 0.001obtained abs = 5.18832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.908657 - Final Residual ratio : 0.000857717 - Residual ratio : 0.000943939 - Slope : -0.0504333 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2271 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.870259 - Final Residual ratio : 0.000713082 - Residual ratio : 0.000819391 - Slope : -0.0362311 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.835241 - Final Residual ratio : 0.000596835 - Residual ratio : 0.000714567 - Slope : -0.0347768 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.3397 - Final Residual ratio : 0.013506 - Residual ratio : 0.000778906 - Slope : -0.641709 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.33549 - Final Residual ratio : 0.00472762 - Residual ratio : 0.000644486 - Slope : -0.261813 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.63101 - Final Residual ratio : 0.0029778 - Residual ratio : 0.000820102 - Slope : -0.13954 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.30465 - Final Residual ratio : 0.00224393 - Residual ratio : 0.00097365 - Slope : -0.0822289 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80804 - Final Residual ratio : 0.00123249 - Residual ratio : 0.00068167 - Slope : -0.0623037 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.46563 - Final Residual ratio : 0.00108176 - Residual ratio : 0.000738086 - Slope : -0.0505017 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2351 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43078 - Final Residual ratio : 0.000985146 - Residual ratio : 0.000688535 - Slope : -0.0493034 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.67 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0497654; expected ratio = 0.0001obtained abs = 4.36144e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119422; expected ratio = 0.001obtained abs = 5.59282; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0187901; expected ratio = 0.0001obtained abs = 1.63714e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122506; expected ratio = 0.001obtained abs = 5.7499; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.73 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0180855; expected ratio = 0.0001obtained abs = 1.58473e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0113724; expected ratio = 0.001obtained abs = 5.3359; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.73 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0216872; expected ratio = 0.0001obtained abs = 1.87874e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0117041; expected ratio = 0.001obtained abs = 5.48834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0203842; expected ratio = 0.0001obtained abs = 1.78174e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119836; expected ratio = 0.001obtained abs = 5.61697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0188005; expected ratio = 0.0001obtained abs = 1.63431e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118753; expected ratio = 0.001obtained abs = 5.57205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0190389; expected ratio = 0.0001obtained abs = 1.66707e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0117229; expected ratio = 0.001obtained abs = 5.49883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0205183; expected ratio = 0.0001obtained abs = 1.78002e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118925; expected ratio = 0.001obtained abs = 5.57843; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.019841; expected ratio = 0.0001obtained abs = 1.73493e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0120168; expected ratio = 0.001obtained abs = 5.63373; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0193104; expected ratio = 0.0001obtained abs = 1.67721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119447; expected ratio = 0.001obtained abs = 5.60379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0195632; expected ratio = 0.0001obtained abs = 1.71246e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119093; expected ratio = 0.001obtained abs = 5.58534; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 345.17 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0202297; expected ratio = 0.0001obtained abs = 1.75582e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119987; expected ratio = 0.001obtained abs = 5.6288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0198063; expected ratio = 0.0001obtained abs = 1.7325e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0120577; expected ratio = 0.001obtained abs = 5.65354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0197427; expected ratio = 0.0001obtained abs = 1.71415e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0120266; expected ratio = 0.001obtained abs = 5.64198; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.019855; expected ratio = 0.0001obtained abs = 1.73773e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0120384; expected ratio = 0.001obtained abs = 5.64536; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.73 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0202089; expected ratio = 0.0001obtained abs = 1.75428e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0120948; expected ratio = 0.001obtained abs = 5.67404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 354.21 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0199421; expected ratio = 0.0001obtained abs = 1.74477e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0121355; expected ratio = 0.001obtained abs = 5.69031; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.73 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0200652; expected ratio = 0.0001obtained abs = 1.74192e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0121361; expected ratio = 0.001obtained abs = 5.69336; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 345.78 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0200691; expected ratio = 0.0001obtained abs = 1.75634e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0121671; expected ratio = 0.001obtained abs = 5.70553; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 348.24 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0203167; expected ratio = 0.0001obtained abs = 1.76369e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122087; expected ratio = 0.001obtained abs = 5.72751; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01189 - Final Residual ratio : 0.000671484 - Residual ratio : 0.000663594 - Slope : -0.0348696 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.896502 - Final Residual ratio : 0.000799155 - Residual ratio : 0.000891414 - Slope : -0.0319894 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.86917 - Final Residual ratio : 0.000820301 - Residual ratio : 0.000943775 - Slope : -0.0361812 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.877719 - Final Residual ratio : 0.000847202 - Residual ratio : 0.000965232 - Slope : -0.0350749 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18013 - Final Residual ratio : 0.00112395 - Residual ratio : 0.000952396 - Slope : -0.0491252 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2411 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.888092 - Final Residual ratio : 0.000880151 - Residual ratio : 0.000991058 - Slope : -0.0354885 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.835125 - Final Residual ratio : 0.000511281 - Residual ratio : 0.000612221 - Slope : -0.0347756 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.781529 - Final Residual ratio : 0.000757328 - Residual ratio : 0.000969033 - Slope : -0.0312309 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.728179 - Final Residual ratio : 0.000564201 - Residual ratio : 0.000774811 - Slope : -0.0259862 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.96982 - Final Residual ratio : 0.000837685 - Residual ratio : 0.000863753 - Slope : -0.0346065 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.04 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0443325; expected ratio = 0.0001obtained abs = 3.97292e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0124953; expected ratio = 0.001obtained abs = 5.8711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.67 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0199079; expected ratio = 0.0001obtained abs = 1.77194e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0126453; expected ratio = 0.001obtained abs = 5.95722; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 346.39 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.020015; expected ratio = 0.0001obtained abs = 1.79613e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118179; expected ratio = 0.001obtained abs = 5.56747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0254536; expected ratio = 0.0001obtained abs = 2.2503e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0126531; expected ratio = 0.001obtained abs = 5.95465; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0229759; expected ratio = 0.0001obtained abs = 2.0522e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0132565; expected ratio = 0.001obtained abs = 6.23488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0210407; expected ratio = 0.0001obtained abs = 1.86919e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0133087; expected ratio = 0.001obtained abs = 6.26795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0217777; expected ratio = 0.0001obtained abs = 1.951e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0132968; expected ratio = 0.001obtained abs = 6.26099; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0240378; expected ratio = 0.0001obtained abs = 2.1298e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0137641; expected ratio = 0.001obtained abs = 6.48037; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.67 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0230469; expected ratio = 0.0001obtained abs = 2.05996e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0140675; expected ratio = 0.001obtained abs = 6.61825; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 347.77 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0224579; expected ratio = 0.0001obtained abs = 1.99271e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0140222; expected ratio = 0.001obtained abs = 6.60291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0231351; expected ratio = 0.0001obtained abs = 2.07201e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0140361; expected ratio = 0.001obtained abs = 6.60739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0242456; expected ratio = 0.0001obtained abs = 2.14911e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142584; expected ratio = 0.001obtained abs = 6.71391; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.14 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0236789; expected ratio = 0.0001obtained abs = 2.11836e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0144047; expected ratio = 0.001obtained abs = 6.77819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0237265; expected ratio = 0.0001obtained abs = 2.1038e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0144075; expected ratio = 0.001obtained abs = 6.78406; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.14 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0241427; expected ratio = 0.0001obtained abs = 2.1622e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0144945; expected ratio = 0.001obtained abs = 6.82231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 344.42 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.024804; expected ratio = 0.0001obtained abs = 2.19871e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0146781; expected ratio = 0.001obtained abs = 6.91184; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0245094; expected ratio = 0.0001obtained abs = 2.19389e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0148242; expected ratio = 0.001obtained abs = 6.97627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.14 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0248516; expected ratio = 0.0001obtained abs = 2.20298e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0149156; expected ratio = 0.001obtained abs = 7.02341; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0250698; expected ratio = 0.0001obtained abs = 2.24529e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0150608; expected ratio = 0.001obtained abs = 7.08839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0255942; expected ratio = 0.0001obtained abs = 2.26871e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0152399; expected ratio = 0.001obtained abs = 7.17654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.663219 - Final Residual ratio : 0.0003866 - Residual ratio : 0.000582915 - Slope : -0.0228563 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.628371 - Final Residual ratio : 0.000588815 - Residual ratio : 0.00093705 - Slope : -0.0224208 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2481 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.613251 - Final Residual ratio : 0.000476422 - Residual ratio : 0.000776878 - Slope : -0.0218848 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.609208 - Final Residual ratio : 0.000475206 - Residual ratio : 0.000780038 - Slope : -0.0225457 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.89161 - Final Residual ratio : 0.000809219 - Residual ratio : 0.000907593 - Slope : -0.0342616 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.631021 - Final Residual ratio : 0.000525324 - Residual ratio : 0.000832499 - Slope : -0.0262706 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.622719 - Final Residual ratio : 0.000454052 - Residual ratio : 0.000729145 - Slope : -0.0259277 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.616814 - Final Residual ratio : 0.000466222 - Residual ratio : 0.000755856 - Slope : -0.0256811 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.608862 - Final Residual ratio : 0.000588584 - Residual ratio : 0.000966695 - Slope : -0.0253447 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.868937 - Final Residual ratio : 0.000635423 - Residual ratio : 0.000731265 - Slope : -0.0321593 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 350.41 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0453469; expected ratio = 0.0001obtained abs = 4.15846e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0155914; expected ratio = 0.001obtained abs = 7.3548; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.14 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.02559; expected ratio = 0.0001obtained abs = 2.32506e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0159541; expected ratio = 0.001obtained abs = 7.54799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.025905; expected ratio = 0.0001obtained abs = 2.37954e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0151583; expected ratio = 0.001obtained abs = 7.17108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.67 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0322303; expected ratio = 0.0001obtained abs = 2.90636e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161701; expected ratio = 0.001obtained abs = 7.64109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448227 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0297123; expected ratio = 0.0001obtained abs = 2.71545e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170411; expected ratio = 0.001obtained abs = 8.04682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0276905; expected ratio = 0.0001obtained abs = 2.51092e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0172778; expected ratio = 0.001obtained abs = 8.17194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0288064; expected ratio = 0.0001obtained abs = 2.64201e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0174206; expected ratio = 0.001obtained abs = 8.23703; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.67 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0318684; expected ratio = 0.0001obtained abs = 2.88061e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0181577; expected ratio = 0.001obtained abs = 8.58491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0308701; expected ratio = 0.0001obtained abs = 2.82396e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018699; expected ratio = 0.001obtained abs = 8.83234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0304447; expected ratio = 0.0001obtained abs = 2.75662e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187853; expected ratio = 0.001obtained abs = 8.88353; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.04 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0314857; expected ratio = 0.0001obtained abs = 2.88811e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0189281; expected ratio = 0.001obtained abs = 8.9473; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0333046; expected ratio = 0.0001obtained abs = 3.01129e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.019367; expected ratio = 0.001obtained abs = 9.15826; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.67 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0327348; expected ratio = 0.0001obtained abs = 2.99896e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0197053; expected ratio = 0.001obtained abs = 9.30994; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0331445; expected ratio = 0.0001obtained abs = 2.99799e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0198579; expected ratio = 0.001obtained abs = 9.39047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 349.01 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.033877; expected ratio = 0.0001obtained abs = 3.10868e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0201203; expected ratio = 0.001obtained abs = 9.50959; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.67 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.035192; expected ratio = 0.0001obtained abs = 3.18181e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0205536; expected ratio = 0.001obtained abs = 9.72026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0349569; expected ratio = 0.0001obtained abs = 3.20599e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0209278; expected ratio = 0.001obtained abs = 9.88882; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.035829; expected ratio = 0.0001obtained abs = 3.23945e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.021238; expected ratio = 0.001obtained abs = 10.0437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0363219; expected ratio = 0.0001obtained abs = 3.33443e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0216157; expected ratio = 0.001obtained abs = 10.2156; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 345.02 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.037522; expected ratio = 0.0001obtained abs = 3.39215e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0220739; expected ratio = 0.001obtained abs = 10.44; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.602675 - Final Residual ratio : 0.000468249 - Residual ratio : 0.000776951 - Slope : -0.0223039 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.585232 - Final Residual ratio : 0.000531014 - Residual ratio : 0.000907357 - Slope : -0.0216556 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.574814 - Final Residual ratio : 0.000427506 - Residual ratio : 0.000743728 - Slope : -0.0212736 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.568157 - Final Residual ratio : 0.000456156 - Residual ratio : 0.00080287 - Slope : -0.021026 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.824568 - Final Residual ratio : 0.000685076 - Residual ratio : 0.000830831 - Slope : -0.0305142 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.57522 - Final Residual ratio : 0.000531689 - Residual ratio : 0.000924322 - Slope : -0.0221034 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.568211 - Final Residual ratio : 0.000501383 - Residual ratio : 0.000882389 - Slope : -0.021835 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.565394 - Final Residual ratio : 0.000511528 - Residual ratio : 0.000904729 - Slope : -0.0225953 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.563387 - Final Residual ratio : 0.000466989 - Residual ratio : 0.000828896 - Slope : -0.0225168 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.815658 - Final Residual ratio : 0.000757398 - Residual ratio : 0.000928573 - Slope : -0.0313423 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 350.88 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0535809; expected ratio = 0.0001obtained abs = 5.03631e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0223871; expected ratio = 0.001obtained abs = 10.6041; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 344.42 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0380578; expected ratio = 0.0001obtained abs = 3.52661e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0232121; expected ratio = 0.001obtained abs = 11.0312; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0389735; expected ratio = 0.0001obtained abs = 3.67247e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0227427; expected ratio = 0.001obtained abs = 10.8052; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0464842; expected ratio = 0.0001obtained abs = 4.27219e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.024074; expected ratio = 0.001obtained abs = 11.4262; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0442298; expected ratio = 0.0001obtained abs = 4.14703e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0253604; expected ratio = 0.001obtained abs = 12.0247; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0426195; expected ratio = 0.0001obtained abs = 3.94082e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0259598; expected ratio = 0.001obtained abs = 12.3342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0443793; expected ratio = 0.0001obtained abs = 4.17949e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0264602; expected ratio = 0.001obtained abs = 12.5654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.73 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0489041; expected ratio = 0.0001obtained abs = 4.50529e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0277042; expected ratio = 0.001obtained abs = 13.158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.048076; expected ratio = 0.0001obtained abs = 4.51641e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0286981; expected ratio = 0.001obtained abs = 13.6119; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.04847; expected ratio = 0.0001obtained abs = 4.47393e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0291646; expected ratio = 0.001obtained abs = 13.8559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0500946; expected ratio = 0.0001obtained abs = 4.72417e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0296824; expected ratio = 0.001obtained abs = 14.0923; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 347.62 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.053525; expected ratio = 0.0001obtained abs = 4.93135e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0306551; expected ratio = 0.001obtained abs = 14.564; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0531415; expected ratio = 0.0001obtained abs = 5.00699e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.031469; expected ratio = 0.001obtained abs = 14.9314; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0548118; expected ratio = 0.0001obtained abs = 5.0524e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0321097; expected ratio = 0.001obtained abs = 15.2563; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0560806; expected ratio = 0.0001obtained abs = 5.29835e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0328668; expected ratio = 0.001obtained abs = 15.603; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0592031; expected ratio = 0.0001obtained abs = 5.45391e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0339809; expected ratio = 0.001obtained abs = 16.1482; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0592816; expected ratio = 0.0001obtained abs = 5.60093e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0349641; expected ratio = 0.001obtained abs = 16.5939; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0618957; expected ratio = 0.0001obtained abs = 5.70248e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0359583; expected ratio = 0.001obtained abs = 17.0892; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0629598; expected ratio = 0.0001obtained abs = 5.96145e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0369857; expected ratio = 0.001obtained abs = 17.5585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0663312; expected ratio = 0.0001obtained abs = 6.11003e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0382751; expected ratio = 0.001obtained abs = 18.1945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.570299 - Final Residual ratio : 0.000537626 - Residual ratio : 0.00094271 - Slope : -0.0227905 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.56124 - Final Residual ratio : 0.000451337 - Residual ratio : 0.000804179 - Slope : -0.0215688 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.555781 - Final Residual ratio : 0.000491377 - Residual ratio : 0.00088412 - Slope : -0.0213573 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.551724 - Final Residual ratio : 0.000462109 - Residual ratio : 0.000837572 - Slope : -0.0212024 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.796935 - Final Residual ratio : 0.000605384 - Residual ratio : 0.00075964 - Slope : -0.0294937 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.557473 - Final Residual ratio : 0.000487394 - Residual ratio : 0.000874292 - Slope : -0.0214225 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.55058 - Final Residual ratio : 0.000500064 - Residual ratio : 0.000908248 - Slope : -0.0211569 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.547312 - Final Residual ratio : 0.000449042 - Residual ratio : 0.000820451 - Slope : -0.0210332 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.545255 - Final Residual ratio : 0.000507938 - Residual ratio : 0.000931561 - Slope : -0.0217899 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.787368 - Final Residual ratio : 0.000773483 - Residual ratio : 0.000982365 - Slope : -0.0302537 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0797671; expected ratio = 0.0001obtained abs = 7.74529e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0390953; expected ratio = 0.001obtained abs = 18.6051; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 348.24 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.069854; expected ratio = 0.0001obtained abs = 6.59814e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0411408; expected ratio = 0.001obtained abs = 19.6575; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.14 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0720178; expected ratio = 0.0001obtained abs = 7.02537e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0416857; expected ratio = 0.001obtained abs = 19.9028; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0830516; expected ratio = 0.0001obtained abs = 7.7749e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0441114; expected ratio = 0.001obtained abs = 21.0517; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0818115; expected ratio = 0.0001obtained abs = 7.95788e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0464128; expected ratio = 0.001obtained abs = 22.1159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 345.17 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0831241; expected ratio = 0.0001obtained abs = 7.83377e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0483787; expected ratio = 0.001obtained abs = 23.12; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0865508; expected ratio = 0.0001obtained abs = 8.48031e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.050199; expected ratio = 0.001obtained abs = 23.9656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0959693; expected ratio = 0.0001obtained abs = 9.01068e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0533954; expected ratio = 0.001obtained abs = 25.5151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0968357; expected ratio = 0.0001obtained abs = 9.49462e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0560229; expected ratio = 0.001obtained abs = 26.717; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.102086; expected ratio = 0.0001obtained abs = 9.61127e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0586061; expected ratio = 0.001obtained abs = 28.0274; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.106098; expected ratio = 0.0001obtained abs = 1.04932e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0609983; expected ratio = 0.001obtained abs = 29.1325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.116712; expected ratio = 0.0001obtained abs = 1.097e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0648154; expected ratio = 0.001obtained abs = 31.0125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 346.39 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.119518; expected ratio = 0.0001obtained abs = 1.18844e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0679996; expected ratio = 0.001obtained abs = 32.4712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.129433; expected ratio = 0.0001obtained abs = 1.21895e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0722033; expected ratio = 0.001obtained abs = 34.5806; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.13547; expected ratio = 0.0001obtained abs = 1.36322e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0760373; expected ratio = 0.001obtained abs = 36.3619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.150309; expected ratio = 0.0001obtained abs = 1.41742e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0824269; expected ratio = 0.001obtained abs = 39.5314; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.15885; expected ratio = 0.0001obtained abs = 1.62223e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0878756; expected ratio = 0.001obtained abs = 42.0673; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.17718; expected ratio = 0.0001obtained abs = 1.67878e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0968218; expected ratio = 0.001obtained abs = 46.5412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.195109; expected ratio = 0.0001obtained abs = 2.05197e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104833; expected ratio = 0.001obtained abs = 50.3353; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.223386; expected ratio = 0.0001obtained abs = 2.13727e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.12055; expected ratio = 0.001obtained abs = 58.21; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.552961 - Final Residual ratio : 0.000546256 - Residual ratio : 0.000987873 - Slope : -0.0220966 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.546529 - Final Residual ratio : 0.000500216 - Residual ratio : 0.00091526 - Slope : -0.0218412 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.543212 - Final Residual ratio : 0.000522625 - Residual ratio : 0.000962102 - Slope : -0.0217076 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.540886 - Final Residual ratio : 0.000487535 - Residual ratio : 0.000901362 - Slope : -0.021616 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.77805 - Final Residual ratio : 0.00057102 - Residual ratio : 0.000733912 - Slope : -0.0287955 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.547734 - Final Residual ratio : 0.000515774 - Residual ratio : 0.00094165 - Slope : -0.0218887 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.541814 - Final Residual ratio : 0.000502044 - Residual ratio : 0.000926599 - Slope : -0.0216525 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.538883 - Final Residual ratio : 0.000501119 - Residual ratio : 0.000929922 - Slope : -0.0215353 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.536972 - Final Residual ratio : 0.00050118 - Residual ratio : 0.000933345 - Slope : -0.0214589 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.770073 - Final Residual ratio : 0.000758489 - Residual ratio : 0.000984957 - Slope : -0.029589 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.290169; expected ratio = 0.0001obtained abs = 3.41048e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138287; expected ratio = 0.001obtained abs = 67.1622; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 348.56 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 480.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.275571; expected ratio = 0.0001obtained abs = 2.93294e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.14784; expected ratio = 0.001obtained abs = 73.5606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 345.78 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.300437; expected ratio = 0.0001obtained abs = 3.64158e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.149657; expected ratio = 0.001obtained abs = 73.0798; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.837060e+05 Mflops = 353.94 -Solve time = 0.00 -Solve flops = 1.679800e+04 Mflops = 492.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.297723; expected ratio = 0.0001obtained abs = 3.05735e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125768; expected ratio = 0.001obtained abs = 61.9624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 346.40 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 478.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.259501; expected ratio = 0.0001obtained abs = 2.7857e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.118124; expected ratio = 0.001obtained abs = 57.7566; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.351857; expected ratio = 0.0001obtained abs = 3.29576e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117413; expected ratio = 0.001obtained abs = 56.4836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 348.39 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.206382; expected ratio = 0.0001obtained abs = 2.24216e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105667; expected ratio = 0.001obtained abs = 50.7469; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.185385; expected ratio = 0.0001obtained abs = 1.93696e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113332; expected ratio = 0.001obtained abs = 55.457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.73 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.29902; expected ratio = 0.0001obtained abs = 3.53815e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144908; expected ratio = 0.001obtained abs = 70.8639; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802780e+05 Mflops = 336.96 -Solve time = 0.00 -Solve flops = 1.663200e+04 Mflops = 474.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.360741; expected ratio = 0.0001obtained abs = 4.02581e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.214226; expected ratio = 0.001obtained abs = 107.182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.867880e+05 Mflops = 358.56 -Solve time = 0.00 -Solve flops = 1.696400e+04 Mflops = 501.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.646121; expected ratio = 0.0001obtained abs = 1.31939e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.316845; expected ratio = 0.001obtained abs = 165.561; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870940e+05 Mflops = 355.56 -Solve time = 0.00 -Solve flops = 1.691600e+04 Mflops = 499.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.516305; expected ratio = 0.0001obtained abs = 1.26552e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.375505; expected ratio = 0.001obtained abs = 213.081; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.840660e+05 Mflops = 353.98 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 479.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.45911; expected ratio = 0.0001obtained abs = 1.55463e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.401665; expected ratio = 0.001obtained abs = 203.379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.789980e+05 Mflops = 338.95 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 490.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.34842; expected ratio = 0.0001obtained abs = 4.58536e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.252457; expected ratio = 0.001obtained abs = 123.809; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835320e+05 Mflops = 345.66 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 491.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.490606; expected ratio = 0.0001obtained abs = 6.31408e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.313489; expected ratio = 0.001obtained abs = 159.237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856360e+05 Mflops = 357.00 -Solve time = 0.00 -Solve flops = 1.693400e+04 Mflops = 483.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.794249; expected ratio = 0.0001obtained abs = 2.50963e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.394953; expected ratio = 0.001obtained abs = 197.199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819060e+05 Mflops = 347.91 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 490.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.520618; expected ratio = 0.0001obtained abs = 1.95437e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.466501; expected ratio = 0.001obtained abs = 275.995; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 341.08 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.91506; expected ratio = 0.0001obtained abs = 2.61339e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.544437; expected ratio = 0.001obtained abs = 287.277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827280e+05 Mflops = 349.32 -Solve time = 0.00 -Solve flops = 1.677200e+04 Mflops = 495.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.530077; expected ratio = 0.0001obtained abs = 7.11665e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.335975; expected ratio = 0.001obtained abs = 162.949; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.901620e+05 Mflops = 359.44 -Solve time = 0.00 -Solve flops = 1.708400e+04 Mflops = 487.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.364304; expected ratio = 0.0001obtained abs = 6.08932e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.233495; expected ratio = 0.001obtained abs = 119.343; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.544199 - Final Residual ratio : 0.000517763 - Residual ratio : 0.000951422 - Slope : -0.0217473 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.538613 - Final Residual ratio : 0.000475145 - Residual ratio : 0.000882165 - Slope : -0.0215255 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.535864 - Final Residual ratio : 0.000481684 - Residual ratio : 0.000898891 - Slope : -0.0214153 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.534073 - Final Residual ratio : 0.000490877 - Residual ratio : 0.00091912 - Slope : -0.0213433 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.763238 - Final Residual ratio : 0.000594433 - Residual ratio : 0.00077883 - Slope : -0.0282461 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.541215 - Final Residual ratio : 0.000512441 - Residual ratio : 0.000946834 - Slope : -0.0216281 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.535935 - Final Residual ratio : 0.000470722 - Residual ratio : 0.000878318 - Slope : -0.0214186 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.533379 - Final Residual ratio : 0.000454853 - Residual ratio : 0.000852777 - Slope : -0.021317 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.531725 - Final Residual ratio : 0.000441057 - Residual ratio : 0.000829483 - Slope : -0.0212514 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.757245 - Final Residual ratio : 0.000735986 - Residual ratio : 0.000971926 - Slope : -0.0290965 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.2951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.2951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.857900e+05 Mflops = 351.81 -Solve time = 0.00 -Solve flops = 1.690400e+04 Mflops = 485.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.294795; expected ratio = 0.0001obtained abs = 4.22318e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.20273; expected ratio = 0.001obtained abs = 107.918; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 344.68 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 473.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.51084; expected ratio = 0.0001obtained abs = 5.54041e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.228056; expected ratio = 0.001obtained abs = 114.252; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 347.29 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.267224; expected ratio = 0.0001obtained abs = 2.80883e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189642; expected ratio = 0.001obtained abs = 91.8051; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.849660e+05 Mflops = 347.74 -Solve time = 0.00 -Solve flops = 1.683800e+04 Mflops = 493.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.384053; expected ratio = 0.0001obtained abs = 4.40326e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.235474; expected ratio = 0.001obtained abs = 114.842; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.836360e+05 Mflops = 352.51 -Solve time = 0.00 -Solve flops = 1.681600e+04 Mflops = 479.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.443684; expected ratio = 0.0001obtained abs = 6.18103e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.277129; expected ratio = 0.001obtained abs = 139.745; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822920e+05 Mflops = 341.33 -Solve time = 0.00 -Solve flops = 1.672600e+04 Mflops = 490.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.554584; expected ratio = 0.0001obtained abs = 6.19312e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.275777; expected ratio = 0.001obtained abs = 140.097; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839440e+05 Mflops = 341.98 -Solve time = 0.00 -Solve flops = 1.690200e+04 Mflops = 482.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.62546; expected ratio = 0.0001obtained abs = 1.12182e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.331268; expected ratio = 0.001obtained abs = 175.042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810700e+05 Mflops = 345.52 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 476.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.397111; expected ratio = 0.0001obtained abs = 7.99314e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.36191; expected ratio = 0.001obtained abs = 194.46; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.833600e+05 Mflops = 351.17 -Solve time = 0.00 -Solve flops = 1.677800e+04 Mflops = 495.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.530359; expected ratio = 0.0001obtained abs = 7.62062e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.332944; expected ratio = 0.001obtained abs = 172.761; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 343.67 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 487.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.367746; expected ratio = 0.0001obtained abs = 4.54909e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242819; expected ratio = 0.001obtained abs = 123.239; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.784120e+05 Mflops = 341.85 -Solve time = 0.00 -Solve flops = 1.658200e+04 Mflops = 473.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.242029; expected ratio = 0.0001obtained abs = 2.74587e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19627; expected ratio = 0.001obtained abs = 96.2781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.849220e+05 Mflops = 348.91 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 493.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.348434; expected ratio = 0.0001obtained abs = 3.68847e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.210999; expected ratio = 0.001obtained abs = 102.12; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.821680e+05 Mflops = 346.20 -Solve time = 0.00 -Solve flops = 1.673600e+04 Mflops = 494.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.324443; expected ratio = 0.0001obtained abs = 3.55619e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.233821; expected ratio = 0.001obtained abs = 115.007; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.849220e+05 Mflops = 340.63 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 480.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.341724; expected ratio = 0.0001obtained abs = 3.95654e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.25973; expected ratio = 0.001obtained abs = 128.998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814980e+05 Mflops = 346.34 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.363701; expected ratio = 0.0001obtained abs = 4.45703e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.27565; expected ratio = 0.001obtained abs = 139.263; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.848700e+05 Mflops = 347.40 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 497.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.487413; expected ratio = 0.0001obtained abs = 4.84616e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.302597; expected ratio = 0.001obtained abs = 146.442; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838040e+05 Mflops = 344.78 -Solve time = 0.00 -Solve flops = 1.680600e+04 Mflops = 492.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.383493; expected ratio = 0.0001obtained abs = 5.11632e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.324784; expected ratio = 0.001obtained abs = 163.505; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838080e+05 Mflops = 352.19 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.402451; expected ratio = 0.0001obtained abs = 4.59767e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.296556; expected ratio = 0.001obtained abs = 152.135; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805400e+05 Mflops = 340.64 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 478.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.616089; expected ratio = 0.0001obtained abs = 5.00253e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.225423; expected ratio = 0.001obtained abs = 107.515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 346.35 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 476.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.299902; expected ratio = 0.0001obtained abs = 2.88255e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134593; expected ratio = 0.001obtained abs = 62.7918; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.2961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.5388 - Final Residual ratio : 0.000485798 - Residual ratio : 0.00090163 - Slope : -0.0215326 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.533586 - Final Residual ratio : 0.000450924 - Residual ratio : 0.000845081 - Slope : -0.0213254 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.531087 - Final Residual ratio : 0.000456154 - Residual ratio : 0.000858908 - Slope : -0.0212252 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.2991 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.529498 - Final Residual ratio : 0.000458841 - Residual ratio : 0.000866559 - Slope : -0.0211615 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.2991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.75157 - Final Residual ratio : 0.000565598 - Residual ratio : 0.000752555 - Slope : -0.027815 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.536594 - Final Residual ratio : 0.000486174 - Residual ratio : 0.000906037 - Slope : -0.0214443 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.531631 - Final Residual ratio : 0.000451955 - Residual ratio : 0.000850129 - Slope : -0.0212472 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.529308 - Final Residual ratio : 0.000441373 - Residual ratio : 0.000833868 - Slope : -0.0211547 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.527838 - Final Residual ratio : 0.00042878 - Residual ratio : 0.000812332 - Slope : -0.0210964 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3051 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.746624 - Final Residual ratio : 0.000724996 - Residual ratio : 0.000971032 - Slope : -0.0286884 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.850180e+05 Mflops = 341.26 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 480.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.213815; expected ratio = 0.0001obtained abs = 1.8829e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0784779; expected ratio = 0.001obtained abs = 36.8412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.836040e+05 Mflops = 347.67 -Solve time = 0.00 -Solve flops = 1.679200e+04 Mflops = 495.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.175252; expected ratio = 0.0001obtained abs = 1.74604e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113194; expected ratio = 0.001obtained abs = 55.308; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805840e+05 Mflops = 346.01 -Solve time = 0.00 -Solve flops = 1.665000e+04 Mflops = 488.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.253792; expected ratio = 0.0001obtained abs = 2.43389e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.148564; expected ratio = 0.001obtained abs = 73.0021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 343.21 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.316069; expected ratio = 0.0001obtained abs = 2.87892e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170231; expected ratio = 0.001obtained abs = 80.1249; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.206951; expected ratio = 0.0001obtained abs = 1.89118e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.135846; expected ratio = 0.001obtained abs = 64.8909; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.264711; expected ratio = 0.0001obtained abs = 2.92307e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.142286; expected ratio = 0.001obtained abs = 69.7973; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 344.30 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 487.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.230021; expected ratio = 0.0001obtained abs = 2.48195e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.151717; expected ratio = 0.001obtained abs = 76.0209; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866980e+05 Mflops = 350.84 -Solve time = 0.00 -Solve flops = 1.692600e+04 Mflops = 499.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.220706; expected ratio = 0.0001obtained abs = 2.21222e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.167408; expected ratio = 0.001obtained abs = 80.3583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.849220e+05 Mflops = 350.17 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 480.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.256032; expected ratio = 0.0001obtained abs = 2.21533e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.13147; expected ratio = 0.001obtained abs = 63.1974; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823260e+05 Mflops = 344.01 -Solve time = 0.00 -Solve flops = 1.671800e+04 Mflops = 477.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.266527; expected ratio = 0.0001obtained abs = 2.87318e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10439; expected ratio = 0.001obtained abs = 50.5913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 344.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.322391; expected ratio = 0.0001obtained abs = 2.84863e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103607; expected ratio = 0.001obtained abs = 49.9609; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.255127; expected ratio = 0.0001obtained abs = 2.69272e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0930045; expected ratio = 0.001obtained abs = 44.5616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.837060e+05 Mflops = 353.29 -Solve time = 0.00 -Solve flops = 1.679800e+04 Mflops = 492.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.158652; expected ratio = 0.0001obtained abs = 1.60192e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0842402; expected ratio = 0.001obtained abs = 41.3733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.73 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0969641; expected ratio = 0.0001obtained abs = 9.80448e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0814973; expected ratio = 0.001obtained abs = 40.1484; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811540e+05 Mflops = 347.74 -Solve time = 0.00 -Solve flops = 1.668200e+04 Mflops = 489.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.22805; expected ratio = 0.0001obtained abs = 2.23125e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137025; expected ratio = 0.001obtained abs = 66.8369; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.849220e+05 Mflops = 350.96 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 480.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.342646; expected ratio = 0.0001obtained abs = 3.34947e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.179326; expected ratio = 0.001obtained abs = 85.7936; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858420e+05 Mflops = 354.63 -Solve time = 0.00 -Solve flops = 1.690800e+04 Mflops = 495.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.207928; expected ratio = 0.0001obtained abs = 2.14221e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.141273; expected ratio = 0.001obtained abs = 69.3281; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811100e+05 Mflops = 347.66 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 489.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.157029; expected ratio = 0.0001obtained abs = 1.61634e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117383; expected ratio = 0.001obtained abs = 56.8752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.226453; expected ratio = 0.0001obtained abs = 2.09753e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102189; expected ratio = 0.001obtained abs = 49.6293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.204709; expected ratio = 0.0001obtained abs = 2.10653e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109699; expected ratio = 0.001obtained abs = 52.9626; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.534882 - Final Residual ratio : 0.000464305 - Residual ratio : 0.000868052 - Slope : -0.0213767 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.529911 - Final Residual ratio : 0.000434102 - Residual ratio : 0.000819197 - Slope : -0.0211791 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.527592 - Final Residual ratio : 0.000437845 - Residual ratio : 0.000829893 - Slope : -0.0210862 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.526134 - Final Residual ratio : 0.000437029 - Residual ratio : 0.000830643 - Slope : -0.0210279 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.741667 - Final Residual ratio : 0.000547684 - Residual ratio : 0.000738451 - Slope : -0.0274489 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.533125 - Final Residual ratio : 0.000464985 - Residual ratio : 0.000872187 - Slope : -0.0213064 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.528325 - Final Residual ratio : 0.000435106 - Residual ratio : 0.000823557 - Slope : -0.0211156 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.526144 - Final Residual ratio : 0.000428312 - Residual ratio : 0.000814059 - Slope : -0.0210286 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.3141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.524788 - Final Residual ratio : 0.000417878 - Residual ratio : 0.00079628 - Slope : -0.0209748 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.737206 - Final Residual ratio : 0.000714264 - Residual ratio : 0.00096888 - Slope : -0.0283266 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858420e+05 Mflops = 353.34 -Solve time = 0.00 -Solve flops = 1.690800e+04 Mflops = 482.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.224176; expected ratio = 0.0001obtained abs = 2.30413e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109754; expected ratio = 0.001obtained abs = 54.5498; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816000e+05 Mflops = 344.03 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.244792; expected ratio = 0.0001obtained abs = 2.98156e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.143031; expected ratio = 0.001obtained abs = 71.178; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.857380e+05 Mflops = 351.87 -Solve time = 0.00 -Solve flops = 1.687000e+04 Mflops = 481.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.381435; expected ratio = 0.0001obtained abs = 3.64473e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172585; expected ratio = 0.001obtained abs = 84.8418; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.73 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.288402; expected ratio = 0.0001obtained abs = 3.48862e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155252; expected ratio = 0.001obtained abs = 76.6618; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802180e+05 Mflops = 348.02 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.248797; expected ratio = 0.0001obtained abs = 3.08184e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.182526; expected ratio = 0.001obtained abs = 92.7923; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.829140e+05 Mflops = 353.87 -Solve time = 0.00 -Solve flops = 1.679800e+04 Mflops = 479.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.496231; expected ratio = 0.0001obtained abs = 8.39917e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.26498; expected ratio = 0.001obtained abs = 141.076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.833800e+05 Mflops = 351.37 -Solve time = 0.00 -Solve flops = 1.677400e+04 Mflops = 491.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.4574; expected ratio = 0.0001obtained abs = 1.01182e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.368788; expected ratio = 0.001obtained abs = 210.707; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.840660e+05 Mflops = 354.63 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 479.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.12183; expected ratio = 0.0001obtained abs = 1.21681e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.418186; expected ratio = 0.001obtained abs = 229.239; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813420e+05 Mflops = 350.02 -Solve time = 0.00 -Solve flops = 1.669400e+04 Mflops = 489.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.633188; expected ratio = 0.0001obtained abs = 4.43933e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.400102; expected ratio = 0.001obtained abs = 185.917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835640e+05 Mflops = 353.83 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.440521; expected ratio = 0.0001obtained abs = 4.92679e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.212199; expected ratio = 0.001obtained abs = 100.528; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.862360e+05 Mflops = 352.65 -Solve time = 0.00 -Solve flops = 1.690400e+04 Mflops = 495.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.279066; expected ratio = 0.0001obtained abs = 2.95478e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.186268; expected ratio = 0.001obtained abs = 89.6418; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.854060e+05 Mflops = 356.56 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.225736; expected ratio = 0.0001obtained abs = 2.72161e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.201912; expected ratio = 0.001obtained abs = 104.038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808960e+05 Mflops = 347.25 -Solve time = 0.00 -Solve flops = 1.667600e+04 Mflops = 492.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.577027; expected ratio = 0.0001obtained abs = 5.15517e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.233391; expected ratio = 0.001obtained abs = 112.475; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835860e+05 Mflops = 352.25 -Solve time = 0.00 -Solve flops = 1.677800e+04 Mflops = 495.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.323857; expected ratio = 0.0001obtained abs = 3.3002e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243686; expected ratio = 0.001obtained abs = 115.204; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 353.57 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.372657; expected ratio = 0.0001obtained abs = 4.7352e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.29227; expected ratio = 0.001obtained abs = 147.318; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843680e+05 Mflops = 353.75 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 496.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.306279; expected ratio = 0.0001obtained abs = 4.19969e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.297908; expected ratio = 0.001obtained abs = 156.109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807300e+05 Mflops = 346.77 -Solve time = 0.00 -Solve flops = 1.665800e+04 Mflops = 492.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.329669; expected ratio = 0.0001obtained abs = 5.26183e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.281706; expected ratio = 0.001obtained abs = 149.486; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846300e+05 Mflops = 353.60 -Solve time = 0.00 -Solve flops = 1.683800e+04 Mflops = 497.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.429625; expected ratio = 0.0001obtained abs = 5.4746e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.333023; expected ratio = 0.001obtained abs = 164.019; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.852820e+05 Mflops = 350.85 -Solve time = 0.00 -Solve flops = 1.685600e+04 Mflops = 497.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.310527; expected ratio = 0.0001obtained abs = 4.24992e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.334917; expected ratio = 0.001obtained abs = 167.791; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846840e+05 Mflops = 351.78 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 479.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.378854; expected ratio = 0.0001obtained abs = 4.53208e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.310265; expected ratio = 0.001obtained abs = 157.518; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.531766 - Final Residual ratio : 0.000448007 - Residual ratio : 0.000842488 - Slope : -0.0212527 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.526958 - Final Residual ratio : 0.00042141 - Residual ratio : 0.000799704 - Slope : -0.0210615 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.524782 - Final Residual ratio : 0.000424431 - Residual ratio : 0.000808775 - Slope : -0.0209743 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.523424 - Final Residual ratio : 0.000421806 - Residual ratio : 0.000805859 - Slope : -0.0209201 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.732674 - Final Residual ratio : 0.000723805 - Residual ratio : 0.000987895 - Slope : -0.0281519 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3211 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.530309 - Final Residual ratio : 0.000441462 - Residual ratio : 0.000832461 - Slope : -0.0211947 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.525588 - Final Residual ratio : 0.000421196 - Residual ratio : 0.000801382 - Slope : -0.0210067 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.523508 - Final Residual ratio : 0.000419915 - Residual ratio : 0.000802119 - Slope : -0.0209235 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.522227 - Final Residual ratio : 0.000410122 - Residual ratio : 0.000785334 - Slope : -0.0208727 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3251 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.728434 - Final Residual ratio : 0.000704052 - Residual ratio : 0.000966529 - Slope : -0.0279896 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819120e+05 Mflops = 346.50 -Solve time = 0.00 -Solve flops = 1.672600e+04 Mflops = 490.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.182578; expected ratio = 0.0001obtained abs = 2.28374e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.25067; expected ratio = 0.001obtained abs = 126.378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816660e+05 Mflops = 346.66 -Solve time = 0.00 -Solve flops = 1.674800e+04 Mflops = 491.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.438682; expected ratio = 0.0001obtained abs = 4.25611e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.239786; expected ratio = 0.001obtained abs = 115.905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859400e+05 Mflops = 350.83 -Solve time = 0.00 -Solve flops = 1.688400e+04 Mflops = 495.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.251036; expected ratio = 0.0001obtained abs = 2.67855e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.252843; expected ratio = 0.001obtained abs = 121.526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855360e+05 Mflops = 350.70 -Solve time = 0.00 -Solve flops = 1.685600e+04 Mflops = 484.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.312687; expected ratio = 0.0001obtained abs = 3.56875e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.276913; expected ratio = 0.001obtained abs = 133.61; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869820e+05 Mflops = 351.37 -Solve time = 0.00 -Solve flops = 1.697400e+04 Mflops = 487.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.439022; expected ratio = 0.0001obtained abs = 7.91341e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.331965; expected ratio = 0.001obtained abs = 181.449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.837380e+05 Mflops = 351.90 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 497.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.997036; expected ratio = 0.0001obtained abs = 0.000221854; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.362961; expected ratio = 0.001obtained abs = 180.325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800260e+05 Mflops = 340.28 -Solve time = 0.00 -Solve flops = 1.667600e+04 Mflops = 492.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.24355; expected ratio = 0.0001obtained abs = 0.00012361; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.291301; expected ratio = 0.001obtained abs = 139.485; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818240e+05 Mflops = 350.31 -Solve time = 0.00 -Solve flops = 1.674800e+04 Mflops = 491.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.40853; expected ratio = 0.0001obtained abs = 7.12719e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.28202; expected ratio = 0.001obtained abs = 138.246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.793300e+05 Mflops = 342.98 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.724004; expected ratio = 0.0001obtained abs = 6.06473e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.24505; expected ratio = 0.001obtained abs = 123.559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.781700e+05 Mflops = 342.01 -Solve time = 0.00 -Solve flops = 1.656800e+04 Mflops = 485.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.45476; expected ratio = 0.0001obtained abs = 5.14085e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.211003; expected ratio = 0.001obtained abs = 105.599; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835600e+05 Mflops = 351.07 -Solve time = 0.00 -Solve flops = 1.684000e+04 Mflops = 480.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.695886; expected ratio = 0.0001obtained abs = 1.56301e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.229223; expected ratio = 0.001obtained abs = 116.216; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.824200e+05 Mflops = 352.75 -Solve time = 0.00 -Solve flops = 1.677400e+04 Mflops = 478.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.469067; expected ratio = 0.0001obtained abs = 8.44151e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.227308; expected ratio = 0.001obtained abs = 118.059; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795940e+05 Mflops = 344.59 -Solve time = 0.00 -Solve flops = 1.665000e+04 Mflops = 491.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.427365; expected ratio = 0.0001obtained abs = 6.37543e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.196503; expected ratio = 0.001obtained abs = 102.363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834080e+05 Mflops = 351.26 -Solve time = 0.00 -Solve flops = 1.679600e+04 Mflops = 496.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.527861; expected ratio = 0.0001obtained abs = 1.14809e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.233118; expected ratio = 0.001obtained abs = 113.762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.833740e+05 Mflops = 350.56 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 496.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.719781; expected ratio = 0.0001obtained abs = 3.87758e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.424934; expected ratio = 0.001obtained abs = 265.086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.824260e+05 Mflops = 350.83 -Solve time = 0.00 -Solve flops = 1.677200e+04 Mflops = 491.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.54071; expected ratio = 0.0001obtained abs = 2.09196e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.344151; expected ratio = 0.001obtained abs = 225.292; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 346.11 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.2509; expected ratio = 0.0001obtained abs = 2.28122e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.324985; expected ratio = 0.001obtained abs = 179.281; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 346.59 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 486.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.486539; expected ratio = 0.0001obtained abs = 6.41037e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.208385; expected ratio = 0.001obtained abs = 107.16; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838320e+05 Mflops = 354.83 -Solve time = 0.00 -Solve flops = 1.680600e+04 Mflops = 479.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.393697; expected ratio = 0.0001obtained abs = 6.5868e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.225706; expected ratio = 0.001obtained abs = 116.854; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809640e+05 Mflops = 347.85 -Solve time = 0.00 -Solve flops = 1.667600e+04 Mflops = 492.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.964613; expected ratio = 0.0001obtained abs = 4.5519e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.217569; expected ratio = 0.001obtained abs = 114.941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.529072 - Final Residual ratio : 0.000432836 - Residual ratio : 0.000818104 - Slope : -0.0211456 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3271 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.524376 - Final Residual ratio : 0.000409235 - Residual ratio : 0.000780423 - Slope : -0.0209587 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.522318 - Final Residual ratio : 0.000411556 - Residual ratio : 0.000787942 - Slope : -0.0208763 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.521043 - Final Residual ratio : 0.000407403 - Residual ratio : 0.000781899 - Slope : -0.0208254 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3301 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.726101 - Final Residual ratio : 0.000715241 - Residual ratio : 0.000985043 - Slope : -0.0278995 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.52774 - Final Residual ratio : 0.000425859 - Residual ratio : 0.000806949 - Slope : -0.0210926 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.5051 - Final Residual ratio : 0.0240157 - Residual ratio : 0.000762278 - Slope : -1.31171 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0089 - Final Residual ratio : 0.00770823 - Residual ratio : 0.000770135 - Slope : -0.370416 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.29912 - Final Residual ratio : 0.00277854 - Residual ratio : 0.000842207 - Slope : -0.137347 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5471 - Final Residual ratio : 0.00238575 - Residual ratio : 0.000672594 - Slope : -0.126597 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.868160e+05 Mflops = 351.69 -Solve time = 0.00 -Solve flops = 1.701600e+04 Mflops = 488.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.12623; expected ratio = 0.0001obtained abs = 3.71654e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189875; expected ratio = 0.001obtained abs = 100.589; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.771060e+05 Mflops = 341.22 -Solve time = 0.00 -Solve flops = 1.653200e+04 Mflops = 488.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.851132; expected ratio = 0.0001obtained abs = 9.84399e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.17735; expected ratio = 0.001obtained abs = 87.2542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.787280e+05 Mflops = 342.46 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.347203; expected ratio = 0.0001obtained abs = 4.29225e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16459; expected ratio = 0.001obtained abs = 80.3453; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.857660e+05 Mflops = 354.49 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 499.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.358122; expected ratio = 0.0001obtained abs = 4.90895e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170523; expected ratio = 0.001obtained abs = 84.9397; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817900e+05 Mflops = 346.90 -Solve time = 0.00 -Solve flops = 1.672000e+04 Mflops = 477.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.25931; expected ratio = 0.0001obtained abs = 3.91523e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155608; expected ratio = 0.001obtained abs = 77.9546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817000e+05 Mflops = 346.10 -Solve time = 0.00 -Solve flops = 1.671600e+04 Mflops = 493.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.206187; expected ratio = 0.0001obtained abs = 3.49675e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.163362; expected ratio = 0.001obtained abs = 84.2645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858060e+05 Mflops = 353.92 -Solve time = 0.00 -Solve flops = 1.690600e+04 Mflops = 495.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.306338; expected ratio = 0.0001obtained abs = 4.7828e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.193158; expected ratio = 0.001obtained abs = 100.357; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806340e+05 Mflops = 346.11 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 475.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.376375; expected ratio = 0.0001obtained abs = 5.13902e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.17044; expected ratio = 0.001obtained abs = 84.7623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812580e+05 Mflops = 345.10 -Solve time = 0.00 -Solve flops = 1.669000e+04 Mflops = 492.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.408918; expected ratio = 0.0001obtained abs = 6.62946e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.342393; expected ratio = 0.001obtained abs = 170.577; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.833840e+05 Mflops = 352.67 -Solve time = 0.00 -Solve flops = 1.677800e+04 Mflops = 478.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.376955; expected ratio = 0.0001obtained abs = 6.16551e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.320694; expected ratio = 0.001obtained abs = 169.597; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802740e+05 Mflops = 345.26 -Solve time = 0.00 -Solve flops = 1.663200e+04 Mflops = 477.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.41512; expected ratio = 0.0001obtained abs = 6.51746e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.287595; expected ratio = 0.001obtained abs = 142.366; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815140e+05 Mflops = 341.86 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 476.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.501083; expected ratio = 0.0001obtained abs = 6.401e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.197826; expected ratio = 0.001obtained abs = 97.7789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804580e+05 Mflops = 347.04 -Solve time = 0.00 -Solve flops = 1.665600e+04 Mflops = 488.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.342764; expected ratio = 0.0001obtained abs = 5.22283e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.213316; expected ratio = 0.001obtained abs = 105.901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.851360e+05 Mflops = 353.93 -Solve time = 0.00 -Solve flops = 1.686400e+04 Mflops = 484.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.269952; expected ratio = 0.0001obtained abs = 4.59203e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242907; expected ratio = 0.001obtained abs = 126.509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805460e+05 Mflops = 345.31 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.335503; expected ratio = 0.0001obtained abs = 6.21742e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.226828; expected ratio = 0.001obtained abs = 119.988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.793560e+05 Mflops = 342.25 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.520209; expected ratio = 0.0001obtained abs = 6.80718e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.244761; expected ratio = 0.001obtained abs = 122.637; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855460e+05 Mflops = 354.87 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 481.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.309188; expected ratio = 0.0001obtained abs = 4.68107e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.21813; expected ratio = 0.001obtained abs = 111.132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.854400e+05 Mflops = 354.51 -Solve time = 0.00 -Solve flops = 1.688400e+04 Mflops = 481.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.25827; expected ratio = 0.0001obtained abs = 3.86246e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.248481; expected ratio = 0.001obtained abs = 125.187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814220e+05 Mflops = 334.04 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 479.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.343008; expected ratio = 0.0001obtained abs = 5.39007e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.24268; expected ratio = 0.001obtained abs = 125.529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796960e+05 Mflops = 342.90 -Solve time = 0.00 -Solve flops = 1.665600e+04 Mflops = 488.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.382577; expected ratio = 0.0001obtained abs = 5.49468e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.254312; expected ratio = 0.001obtained abs = 126.762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84943 - Final Residual ratio : 0.00220712 - Residual ratio : 0.000774584 - Slope : -0.101686 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.33336 - Final Residual ratio : 0.00185599 - Residual ratio : 0.000795412 - Slope : -0.0832681 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83462 - Final Residual ratio : 0.00165474 - Residual ratio : 0.000901953 - Slope : -0.0654632 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41369 - Final Residual ratio : 0.00105985 - Residual ratio : 0.000749704 - Slope : -0.0504511 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4988 - Final Residual ratio : 0.00135901 - Residual ratio : 0.000906728 - Slope : -0.0554609 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03955 - Final Residual ratio : 0.000997453 - Residual ratio : 0.000959503 - Slope : -0.0451546 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.956129 - Final Residual ratio : 0.000891032 - Residual ratio : 0.000931916 - Slope : -0.0382095 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.92579 - Final Residual ratio : 0.000814684 - Residual ratio : 0.000879988 - Slope : -0.0660697 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.887745 - Final Residual ratio : 0.000839806 - Residual ratio : 0.000945999 - Slope : -0.0403139 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21609 - Final Residual ratio : 0.000782809 - Residual ratio : 0.000643708 - Slope : -0.0506379 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.857880e+05 Mflops = 353.88 -Solve time = 0.00 -Solve flops = 1.691200e+04 Mflops = 469.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.323377; expected ratio = 0.0001obtained abs = 5.57635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.2362; expected ratio = 0.001obtained abs = 124.028; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.836300e+05 Mflops = 353.14 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 492.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.230187; expected ratio = 0.0001obtained abs = 3.85282e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.231299; expected ratio = 0.001obtained abs = 117.861; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.853860e+05 Mflops = 355.05 -Solve time = 0.00 -Solve flops = 1.688200e+04 Mflops = 498.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.273672; expected ratio = 0.0001obtained abs = 4.38901e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.20542; expected ratio = 0.001obtained abs = 105.601; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.791960e+05 Mflops = 344.61 -Solve time = 0.00 -Solve flops = 1.662000e+04 Mflops = 487.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.358842; expected ratio = 0.0001obtained abs = 4.82072e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.162524; expected ratio = 0.001obtained abs = 79.2392; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800200e+05 Mflops = 346.20 -Solve time = 0.00 -Solve flops = 1.663200e+04 Mflops = 487.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.501256; expected ratio = 0.0001obtained abs = 7.4084e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.305964; expected ratio = 0.001obtained abs = 150.657; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.836340e+05 Mflops = 355.27 -Solve time = 0.00 -Solve flops = 1.679200e+04 Mflops = 479.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.392411; expected ratio = 0.0001obtained abs = 5.92802e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.299448; expected ratio = 0.001obtained abs = 153.087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796320e+05 Mflops = 346.25 -Solve time = 0.00 -Solve flops = 1.662400e+04 Mflops = 487.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.316139; expected ratio = 0.0001obtained abs = 4.62588e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.261546; expected ratio = 0.001obtained abs = 130.918; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.781380e+05 Mflops = 343.21 -Solve time = 0.00 -Solve flops = 1.656800e+04 Mflops = 489.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.361978; expected ratio = 0.0001obtained abs = 4.44886e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.205583; expected ratio = 0.001obtained abs = 102.036; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835740e+05 Mflops = 346.36 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.364778; expected ratio = 0.0001obtained abs = 5.41231e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.230653; expected ratio = 0.001obtained abs = 115.176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842800e+05 Mflops = 355.04 -Solve time = 0.00 -Solve flops = 1.683000e+04 Mflops = 483.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.43171; expected ratio = 0.0001obtained abs = 7.56449e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.293221; expected ratio = 0.001obtained abs = 151.998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.823160e+05 Mflops = 348.54 -Solve time = 0.00 -Solve flops = 1.674400e+04 Mflops = 481.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.311726; expected ratio = 0.0001obtained abs = 5.19036e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.262566; expected ratio = 0.001obtained abs = 134.155; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818800e+05 Mflops = 349.78 -Solve time = 0.00 -Solve flops = 1.671800e+04 Mflops = 490.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.390404; expected ratio = 0.0001obtained abs = 5.4278e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242392; expected ratio = 0.001obtained abs = 121.971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.860220e+05 Mflops = 355.62 -Solve time = 0.00 -Solve flops = 1.691800e+04 Mflops = 499.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.314884; expected ratio = 0.0001obtained abs = 4.81843e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.196745; expected ratio = 0.001obtained abs = 101.812; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843340e+05 Mflops = 355.15 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 493.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.268481; expected ratio = 0.0001obtained abs = 3.98058e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.22807; expected ratio = 0.001obtained abs = 115.086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810400e+05 Mflops = 349.44 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 493.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.282054; expected ratio = 0.0001obtained abs = 4.53287e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249498; expected ratio = 0.001obtained abs = 131.526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810240e+05 Mflops = 340.33 -Solve time = 0.00 -Solve flops = 1.671000e+04 Mflops = 476.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.400552; expected ratio = 0.0001obtained abs = 7.98803e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.245044; expected ratio = 0.001obtained abs = 128.045; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806200e+05 Mflops = 341.40 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 492.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.32958; expected ratio = 0.0001obtained abs = 6.16861e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.219405; expected ratio = 0.001obtained abs = 120.017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807760e+05 Mflops = 361.58 -Solve time = 0.00 -Solve flops = 1.667400e+04 Mflops = 518.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.248526; expected ratio = 0.0001obtained abs = 4.82729e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243729; expected ratio = 0.001obtained abs = 126.479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.840660e+05 Mflops = 355.45 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 479.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.197918; expected ratio = 0.0001obtained abs = 3.4865e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.184702; expected ratio = 0.001obtained abs = 96.9905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813960e+05 Mflops = 347.57 -Solve time = 0.00 -Solve flops = 1.669000e+04 Mflops = 489.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.222014; expected ratio = 0.0001obtained abs = 3.46288e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.136681; expected ratio = 0.001obtained abs = 69.7905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.798217 - Final Residual ratio : 0.000637205 - Residual ratio : 0.000798285 - Slope : -0.0332325 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.698941 - Final Residual ratio : 0.000680625 - Residual ratio : 0.000973796 - Slope : -0.0258615 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.637351 - Final Residual ratio : 0.000324982 - Residual ratio : 0.000509895 - Slope : -0.0227509 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.593878 - Final Residual ratio : 0.000501252 - Residual ratio : 0.000844031 - Slope : -0.021192 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.917641 - Final Residual ratio : 0.00068516 - Residual ratio : 0.000746653 - Slope : -0.0327484 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.571563 - Final Residual ratio : 0.000445108 - Residual ratio : 0.000778755 - Slope : -0.0203971 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.540839 - Final Residual ratio : 0.000467727 - Residual ratio : 0.000864817 - Slope : -0.0207835 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.534709 - Final Residual ratio : 0.000388579 - Residual ratio : 0.000726711 - Slope : -0.0222634 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.534796 - Final Residual ratio : 0.00047776 - Residual ratio : 0.00089335 - Slope : -0.0222632 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.870142 - Final Residual ratio : 0.000677449 - Residual ratio : 0.00077855 - Slope : -0.0347786 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842640e+05 Mflops = 353.55 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 443.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.139192; expected ratio = 0.0001obtained abs = 2.33433e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109444; expected ratio = 0.001obtained abs = 55.9729; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.840660e+05 Mflops = 354.79 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 440.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.163206; expected ratio = 0.0001obtained abs = 2.91336e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144523; expected ratio = 0.001obtained abs = 77.2525; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.824080e+05 Mflops = 348.71 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 442.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.234633; expected ratio = 0.0001obtained abs = 4.78799e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.20466; expected ratio = 0.001obtained abs = 115.582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808080e+05 Mflops = 347.71 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 439.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.270482; expected ratio = 0.0001obtained abs = 4.66616e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.263886; expected ratio = 0.001obtained abs = 136.766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839640e+05 Mflops = 353.78 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 440.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.172572; expected ratio = 0.0001obtained abs = 3.26341e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.202099; expected ratio = 0.001obtained abs = 106.752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810020e+05 Mflops = 348.73 -Solve time = 0.00 -Solve flops = 1.667400e+04 Mflops = 439.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.180307; expected ratio = 0.0001obtained abs = 3.0778e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.154912; expected ratio = 0.001obtained abs = 81.3658; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810460e+05 Mflops = 342.21 -Solve time = 0.00 -Solve flops = 1.667600e+04 Mflops = 439.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.165903; expected ratio = 0.0001obtained abs = 2.86153e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.196912; expected ratio = 0.001obtained abs = 103.578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.850200e+05 Mflops = 355.81 -Solve time = 0.00 -Solve flops = 1.686600e+04 Mflops = 442.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.217674; expected ratio = 0.0001obtained abs = 4.06076e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.257052; expected ratio = 0.001obtained abs = 134.368; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838200e+05 Mflops = 353.51 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 454.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.204973; expected ratio = 0.0001obtained abs = 4.43293e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.216738; expected ratio = 0.001obtained abs = 123.036; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819820e+05 Mflops = 349.97 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 441.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.505115; expected ratio = 0.0001obtained abs = 8.19029e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.235254; expected ratio = 0.001obtained abs = 125.384; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802820e+05 Mflops = 347.50 -Solve time = 0.00 -Solve flops = 1.663800e+04 Mflops = 436.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.306818; expected ratio = 0.0001obtained abs = 4.30405e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.227329; expected ratio = 0.001obtained abs = 114.62; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.833080e+05 Mflops = 351.88 -Solve time = 0.00 -Solve flops = 1.677400e+04 Mflops = 442.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.237117; expected ratio = 0.0001obtained abs = 4.07672e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.176486; expected ratio = 0.001obtained abs = 91.7283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.837260e+05 Mflops = 346.03 -Solve time = 0.00 -Solve flops = 1.679800e+04 Mflops = 443.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.226065; expected ratio = 0.0001obtained abs = 4.28091e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.235508; expected ratio = 0.001obtained abs = 125.848; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.817620e+05 Mflops = 348.27 -Solve time = 0.00 -Solve flops = 1.672400e+04 Mflops = 441.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.28501; expected ratio = 0.0001obtained abs = 5.06269e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.234367; expected ratio = 0.001obtained abs = 130.253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813420e+05 Mflops = 347.47 -Solve time = 0.00 -Solve flops = 1.669400e+04 Mflops = 451.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.276647; expected ratio = 0.0001obtained abs = 4.0354e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.24982; expected ratio = 0.001obtained abs = 126.026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838020e+05 Mflops = 354.28 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 440.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.206025; expected ratio = 0.0001obtained abs = 3.13065e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185778; expected ratio = 0.001obtained abs = 93.0189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805620e+05 Mflops = 347.88 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 439.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.329596; expected ratio = 0.0001obtained abs = 6.74128e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.20907; expected ratio = 0.001obtained abs = 111.127; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859020e+05 Mflops = 356.86 -Solve time = 0.00 -Solve flops = 1.691200e+04 Mflops = 446.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.318892; expected ratio = 0.0001obtained abs = 5.78275e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.206356; expected ratio = 0.001obtained abs = 114.312; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795600e+05 Mflops = 345.31 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 435.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.541289; expected ratio = 0.0001obtained abs = 7.07603e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.190036; expected ratio = 0.001obtained abs = 96.8678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.798680e+05 Mflops = 338.61 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 438.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.00398; expected ratio = 0.0001obtained abs = 8.2213e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.254861; expected ratio = 0.001obtained abs = 128.475; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.557275 - Final Residual ratio : 0.000435708 - Residual ratio : 0.000781855 - Slope : -0.0232017 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.536836 - Final Residual ratio : 0.000346285 - Residual ratio : 0.000645047 - Slope : -0.0223538 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.529438 - Final Residual ratio : 0.00039508 - Residual ratio : 0.000746225 - Slope : -0.0220434 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.522808 - Final Residual ratio : 0.000403638 - Residual ratio : 0.000772058 - Slope : -0.0208962 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.830655 - Final Residual ratio : 0.000789005 - Residual ratio : 0.000949859 - Slope : -0.0307358 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.526811 - Final Residual ratio : 0.000401658 - Residual ratio : 0.000762433 - Slope : -0.0194966 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.508415 - Final Residual ratio : 0.000423665 - Residual ratio : 0.000833304 - Slope : -0.0195381 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.503307 - Final Residual ratio : 0.00044473 - Residual ratio : 0.000883614 - Slope : -0.0201145 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.50092 - Final Residual ratio : 0.000439259 - Residual ratio : 0.000876904 - Slope : -0.0208534 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.801119 - Final Residual ratio : 0.000614446 - Residual ratio : 0.000766985 - Slope : -0.0296483 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858420e+05 Mflops = 352.70 -Solve time = 0.00 -Solve flops = 1.690800e+04 Mflops = 482.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.55313; expected ratio = 0.0001obtained abs = 6.26186e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.212591; expected ratio = 0.001obtained abs = 109.027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809440e+05 Mflops = 346.07 -Solve time = 0.00 -Solve flops = 1.667000e+04 Mflops = 488.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.885018; expected ratio = 0.0001obtained abs = 1.56835e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.197693; expected ratio = 0.001obtained abs = 106.161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813920e+05 Mflops = 345.51 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 489.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.318478; expected ratio = 0.0001obtained abs = 5.1203e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.229693; expected ratio = 0.001obtained abs = 119.707; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.852380e+05 Mflops = 352.84 -Solve time = 0.00 -Solve flops = 1.687200e+04 Mflops = 494.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.441329; expected ratio = 0.0001obtained abs = 6.51836e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.181847; expected ratio = 0.001obtained abs = 95.1494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814200e+05 Mflops = 345.56 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 489.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.401641; expected ratio = 0.0001obtained abs = 5.62661e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.208952; expected ratio = 0.001obtained abs = 106.627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.808120e+05 Mflops = 340.39 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 477.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.00409; expected ratio = 0.0001obtained abs = 0.000169344; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.43573; expected ratio = 0.001obtained abs = 225.684; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.921700e+05 Mflops = 357.28 -Solve time = 0.00 -Solve flops = 1.718600e+04 Mflops = 507.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.56639; expected ratio = 0.0001obtained abs = 0.000169532; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.47425; expected ratio = 0.001obtained abs = 206.45; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.910600e+05 Mflops = 363.27 -Solve time = 0.00 -Solve flops = 1.720600e+04 Mflops = 490.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.859083; expected ratio = 0.0001obtained abs = 0.00028949; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.389986; expected ratio = 0.001obtained abs = 188.187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856260e+05 Mflops = 347.58 -Solve time = 0.00 -Solve flops = 1.688400e+04 Mflops = 481.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.18112; expected ratio = 0.0001obtained abs = 0.000190427; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.480627; expected ratio = 0.001obtained abs = 305.666; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812280e+05 Mflops = 340.71 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 487.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.604093; expected ratio = 0.0001obtained abs = 6.28645e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.360185; expected ratio = 0.001obtained abs = 235.783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.833980e+05 Mflops = 344.02 -Solve time = 0.00 -Solve flops = 1.674200e+04 Mflops = 480.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.489952; expected ratio = 0.0001obtained abs = 3.5487e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.253298; expected ratio = 0.001obtained abs = 167.937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839800e+05 Mflops = 342.05 -Solve time = 0.00 -Solve flops = 1.677800e+04 Mflops = 478.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.344629; expected ratio = 0.0001obtained abs = 2.23491e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.27279; expected ratio = 0.001obtained abs = 168.682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.891880e+05 Mflops = 353.61 -Solve time = 0.00 -Solve flops = 1.702800e+04 Mflops = 502.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.229139; expected ratio = 0.0001obtained abs = 1.48816e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.298903; expected ratio = 0.001obtained abs = 189.054; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861960e+05 Mflops = 351.94 -Solve time = 0.00 -Solve flops = 1.687400e+04 Mflops = 494.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.382407; expected ratio = 0.0001obtained abs = 1.95633e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.222737; expected ratio = 0.001obtained abs = 138.894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812880e+05 Mflops = 341.44 -Solve time = 0.00 -Solve flops = 1.663200e+04 Mflops = 487.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.470568; expected ratio = 0.0001obtained abs = 1.77266e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189489; expected ratio = 0.001obtained abs = 119.508; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818820e+05 Mflops = 347.07 -Solve time = 0.00 -Solve flops = 1.671800e+04 Mflops = 493.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.378485; expected ratio = 0.0001obtained abs = 1.70702e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.369519; expected ratio = 0.001obtained abs = 219.229; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.820840e+05 Mflops = 341.55 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 476.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.397238; expected ratio = 0.0001obtained abs = 1.55342e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.293941; expected ratio = 0.001obtained abs = 182.052; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826240e+05 Mflops = 343.80 -Solve time = 0.00 -Solve flops = 1.670000e+04 Mflops = 493.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.998803; expected ratio = 0.0001obtained abs = 0.000170965; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.23684; expected ratio = 0.001obtained abs = 141.206; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.778140e+05 Mflops = 337.93 -Solve time = 0.00 -Solve flops = 1.652600e+04 Mflops = 474.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.17797; expected ratio = 0.0001obtained abs = 0.000137389; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242991; expected ratio = 0.001obtained abs = 145.108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.827220e+05 Mflops = 350.11 -Solve time = 0.00 -Solve flops = 1.678600e+04 Mflops = 478.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.916744; expected ratio = 0.0001obtained abs = 2.47771e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242395; expected ratio = 0.001obtained abs = 138.364; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.514287 - Final Residual ratio : 0.000411065 - Residual ratio : 0.00079929 - Slope : -0.0214115 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.502457 - Final Residual ratio : 0.000340068 - Residual ratio : 0.000676812 - Slope : -0.0209215 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.500599 - Final Residual ratio : 0.000335758 - Residual ratio : 0.000670713 - Slope : -0.0208443 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.499411 - Final Residual ratio : 0.000332732 - Residual ratio : 0.000666249 - Slope : -0.0207949 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.79145 - Final Residual ratio : 0.000594502 - Residual ratio : 0.000751156 - Slope : -0.0292909 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.509804 - Final Residual ratio : 0.00049074 - Residual ratio : 0.000962606 - Slope : -0.0212214 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.497272 - Final Residual ratio : 0.000412436 - Residual ratio : 0.000829397 - Slope : -0.0207025 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.494411 - Final Residual ratio : 0.000379064 - Residual ratio : 0.000766699 - Slope : -0.0205847 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.492758 - Final Residual ratio : 0.00037298 - Residual ratio : 0.000756922 - Slope : -0.0205161 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.774186 - Final Residual ratio : 0.000585655 - Residual ratio : 0.000756479 - Slope : -0.0286519 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805340e+05 Mflops = 345.13 -Solve time = 0.00 -Solve flops = 1.667000e+04 Mflops = 475.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.662071; expected ratio = 0.0001obtained abs = 1.32698e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164765; expected ratio = 0.001obtained abs = 91.3225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802760e+05 Mflops = 346.69 -Solve time = 0.00 -Solve flops = 1.662000e+04 Mflops = 487.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.337032; expected ratio = 0.0001obtained abs = 7.99555e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.297021; expected ratio = 0.001obtained abs = 161.941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856200e+05 Mflops = 356.97 -Solve time = 0.00 -Solve flops = 1.688800e+04 Mflops = 495.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.34579; expected ratio = 0.0001obtained abs = 8.76365e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.313715; expected ratio = 0.001obtained abs = 176.924; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.835920e+05 Mflops = 354.53 -Solve time = 0.00 -Solve flops = 1.679200e+04 Mflops = 492.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.187316; expected ratio = 0.0001obtained abs = 5.29817e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249897; expected ratio = 0.001obtained abs = 152.743; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.785620e+05 Mflops = 344.03 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 486.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.429296; expected ratio = 0.0001obtained abs = 8.99553e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.309174; expected ratio = 0.001obtained abs = 180.63; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.802920e+05 Mflops = 348.00 -Solve time = 0.00 -Solve flops = 1.664600e+04 Mflops = 491.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.24968; expected ratio = 0.0001obtained abs = 4.32094e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.230061; expected ratio = 0.001obtained abs = 121.332; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841680e+05 Mflops = 355.48 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 483.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.182899; expected ratio = 0.0001obtained abs = 3.14508e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166665; expected ratio = 0.001obtained abs = 89.2816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.809580e+05 Mflops = 348.00 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 493.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.323743; expected ratio = 0.0001obtained abs = 7.01158e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.215404; expected ratio = 0.001obtained abs = 122.91; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801860e+05 Mflops = 347.79 -Solve time = 0.00 -Solve flops = 1.663200e+04 Mflops = 487.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.219976; expected ratio = 0.0001obtained abs = 4.20829e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.255155; expected ratio = 0.001obtained abs = 138.62; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.844860e+05 Mflops = 355.60 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 480.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.261978; expected ratio = 0.0001obtained abs = 5.37042e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.161751; expected ratio = 0.001obtained abs = 89.9431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859280e+05 Mflops = 353.51 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 482.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.122928; expected ratio = 0.0001obtained abs = 2.4849e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138311; expected ratio = 0.001obtained abs = 75.6909; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811080e+05 Mflops = 350.38 -Solve time = 0.00 -Solve flops = 1.668600e+04 Mflops = 476.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.246046; expected ratio = 0.0001obtained abs = 5.52708e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170624; expected ratio = 0.001obtained abs = 94.2693; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841680e+05 Mflops = 356.30 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 493.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.313378; expected ratio = 0.0001obtained abs = 6.15618e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.184805; expected ratio = 0.001obtained abs = 107.476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.790140e+05 Mflops = 338.37 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 476.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.329151; expected ratio = 0.0001obtained abs = 5.36077e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.191847; expected ratio = 0.001obtained abs = 105.557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796100e+05 Mflops = 347.48 -Solve time = 0.00 -Solve flops = 1.660600e+04 Mflops = 487.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.14349; expected ratio = 0.0001obtained abs = 2.31805e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.209405; expected ratio = 0.001obtained abs = 106.748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.828920e+05 Mflops = 352.37 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 491.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.239636; expected ratio = 0.0001obtained abs = 4.21548e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166454; expected ratio = 0.001obtained abs = 90.4228; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.801480e+05 Mflops = 343.14 -Solve time = 0.00 -Solve flops = 1.663800e+04 Mflops = 477.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.312773; expected ratio = 0.0001obtained abs = 6.7404e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.167062; expected ratio = 0.001obtained abs = 95.5357; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.816580e+05 Mflops = 349.35 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.156309; expected ratio = 0.0001obtained abs = 3.25107e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.21146; expected ratio = 0.001obtained abs = 118.763; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841260e+05 Mflops = 355.40 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 493.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.381768; expected ratio = 0.0001obtained abs = 6.4082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.165131; expected ratio = 0.001obtained abs = 91.8277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.805780e+05 Mflops = 348.55 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 478.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.234253; expected ratio = 0.0001obtained abs = 3.81204e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.173055; expected ratio = 0.001obtained abs = 92.4462; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.503202 - Final Residual ratio : 0.00044058 - Residual ratio : 0.000875553 - Slope : -0.0209484 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.492997 - Final Residual ratio : 0.000366701 - Residual ratio : 0.00074382 - Slope : -0.0205263 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.491479 - Final Residual ratio : 0.000348965 - Residual ratio : 0.000710031 - Slope : -0.0204637 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.490711 - Final Residual ratio : 0.000336401 - Residual ratio : 0.000685538 - Slope : -0.0204323 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.76497 - Final Residual ratio : 0.000563852 - Residual ratio : 0.000737091 - Slope : -0.0283113 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.501012 - Final Residual ratio : 0.000410723 - Residual ratio : 0.000819786 - Slope : -0.0208584 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.490954 - Final Residual ratio : 0.000323996 - Residual ratio : 0.000659932 - Slope : -0.0204429 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.489134 - Final Residual ratio : 0.000320533 - Residual ratio : 0.000655306 - Slope : -0.0203672 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.488053 - Final Residual ratio : 0.000308362 - Residual ratio : 0.000631821 - Slope : -0.0203227 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.753089 - Final Residual ratio : 0.000558189 - Residual ratio : 0.000741199 - Slope : -0.0278715 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795660e+05 Mflops = 344.06 -Solve time = 0.00 -Solve flops = 1.660400e+04 Mflops = 473.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.277348; expected ratio = 0.0001obtained abs = 5.60761e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.315837; expected ratio = 0.001obtained abs = 167.654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.849300e+05 Mflops = 354.99 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 494.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.33545; expected ratio = 0.0001obtained abs = 7.63328e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.257449; expected ratio = 0.001obtained abs = 138.195; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812740e+05 Mflops = 348.61 -Solve time = 0.00 -Solve flops = 1.671600e+04 Mflops = 490.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.159891; expected ratio = 0.0001obtained abs = 3.79097e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.197634; expected ratio = 0.001obtained abs = 117.909; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.818000e+05 Mflops = 339.20 -Solve time = 0.00 -Solve flops = 1.673400e+04 Mflops = 477.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.715107; expected ratio = 0.0001obtained abs = 1.11771e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.280523; expected ratio = 0.001obtained abs = 153.556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855120e+05 Mflops = 350.65 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 498.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.323477; expected ratio = 0.0001obtained abs = 4.55816e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.23616; expected ratio = 0.001obtained abs = 117.542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855900e+05 Mflops = 354.96 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 495.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.357648; expected ratio = 0.0001obtained abs = 5.37141e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.200575; expected ratio = 0.001obtained abs = 101.016; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.800980e+05 Mflops = 345.08 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 487.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.22096; expected ratio = 0.0001obtained abs = 3.31301e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123067; expected ratio = 0.001obtained abs = 63.9038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.786700e+05 Mflops = 341.57 -Solve time = 0.00 -Solve flops = 1.662400e+04 Mflops = 487.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.244586; expected ratio = 0.0001obtained abs = 4.04094e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.287293; expected ratio = 0.001obtained abs = 147.099; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.832040e+05 Mflops = 351.68 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 496.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.48532; expected ratio = 0.0001obtained abs = 6.01654e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.307908; expected ratio = 0.001obtained abs = 156.564; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.851940e+05 Mflops = 353.39 -Solve time = 0.00 -Solve flops = 1.691400e+04 Mflops = 499.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.26737; expected ratio = 0.0001obtained abs = 4.23177e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.2821; expected ratio = 0.001obtained abs = 145.09; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.825820e+05 Mflops = 339.45 -Solve time = 0.00 -Solve flops = 1.676600e+04 Mflops = 491.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.621488; expected ratio = 0.0001obtained abs = 7.01138e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.269516; expected ratio = 0.001obtained abs = 134.357; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.865900e+05 Mflops = 354.61 -Solve time = 0.00 -Solve flops = 1.695200e+04 Mflops = 500.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.414864; expected ratio = 0.0001obtained abs = 6.6059e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249603; expected ratio = 0.001obtained abs = 123.253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839560e+05 Mflops = 353.12 -Solve time = 0.00 -Solve flops = 1.679600e+04 Mflops = 492.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.334778; expected ratio = 0.0001obtained abs = 4.42103e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.238518; expected ratio = 0.001obtained abs = 121.712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855840e+05 Mflops = 354.14 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 485.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.275318; expected ratio = 0.0001obtained abs = 4.70538e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.255251; expected ratio = 0.001obtained abs = 137.908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.812900e+05 Mflops = 346.73 -Solve time = 0.00 -Solve flops = 1.669000e+04 Mflops = 489.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.62055; expected ratio = 0.0001obtained abs = 7.06983e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.294148; expected ratio = 0.001obtained abs = 146.309; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.871020e+05 Mflops = 351.60 -Solve time = 0.00 -Solve flops = 1.694800e+04 Mflops = 500.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.318301; expected ratio = 0.0001obtained abs = 4.15338e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.228301; expected ratio = 0.001obtained abs = 111.068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856500e+05 Mflops = 351.55 -Solve time = 0.00 -Solve flops = 1.686800e+04 Mflops = 481.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.255373; expected ratio = 0.0001obtained abs = 2.97448e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.236573; expected ratio = 0.001obtained abs = 115.321; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.852780e+05 Mflops = 352.91 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 494.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.298306; expected ratio = 0.0001obtained abs = 4.5782e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.236844; expected ratio = 0.001obtained abs = 125.656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807840e+05 Mflops = 345.61 -Solve time = 0.00 -Solve flops = 1.672000e+04 Mflops = 490.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.714383; expected ratio = 0.0001obtained abs = 7.04755e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243755; expected ratio = 0.001obtained abs = 119.164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870580e+05 Mflops = 352.30 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 483.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.378871; expected ratio = 0.0001obtained abs = 4.94235e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.208502; expected ratio = 0.001obtained abs = 101.08; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.497578 - Final Residual ratio : 0.000385613 - Residual ratio : 0.000774981 - Slope : -0.0207163 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.48844 - Final Residual ratio : 0.000331953 - Residual ratio : 0.000679619 - Slope : -0.0203378 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.487071 - Final Residual ratio : 0.000343163 - Residual ratio : 0.000704544 - Slope : -0.0202803 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.486311 - Final Residual ratio : 0.00031676 - Residual ratio : 0.000651354 - Slope : -0.0202497 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.743097 - Final Residual ratio : 0.000551657 - Residual ratio : 0.000742376 - Slope : -0.0275017 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.2762 - Final Residual ratio : 0.0271844 - Residual ratio : 0.000749373 - Slope : -1.51038 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0475 - Final Residual ratio : 0.00893712 - Residual ratio : 0.000741824 - Slope : -0.481542 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.6598 - Final Residual ratio : 0.00852209 - Residual ratio : 0.000984098 - Slope : -0.346051 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.54989 - Final Residual ratio : 0.0037004 - Residual ratio : 0.000813296 - Slope : -0.162364 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 30 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.98957 - Final Residual ratio : 0.00416948 - Residual ratio : 0.000835639 - Slope : -0.17805 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.3951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.3951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.864660e+05 Mflops = 351.19 -Solve time = 0.00 -Solve flops = 1.690200e+04 Mflops = 495.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.240055; expected ratio = 0.0001obtained abs = 2.99604e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.233131; expected ratio = 0.001obtained abs = 115.334; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869400e+05 Mflops = 350.66 -Solve time = 0.00 -Solve flops = 1.694400e+04 Mflops = 500.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.292897; expected ratio = 0.0001obtained abs = 4.78319e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242045; expected ratio = 0.001obtained abs = 129.652; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.848780e+05 Mflops = 351.51 -Solve time = 0.00 -Solve flops = 1.692600e+04 Mflops = 499.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.545025; expected ratio = 0.0001obtained abs = 6.9054e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249601; expected ratio = 0.001obtained abs = 130.227; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859560e+05 Mflops = 354.85 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 500.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.454477; expected ratio = 0.0001obtained abs = 5.60489e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.261111; expected ratio = 0.001obtained abs = 128.362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.862580e+05 Mflops = 346.29 -Solve time = 0.00 -Solve flops = 1.691400e+04 Mflops = 482.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.286285; expected ratio = 0.0001obtained abs = 4.12664e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.270082; expected ratio = 0.001obtained abs = 135.257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845560e+05 Mflops = 354.27 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 494.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.431345; expected ratio = 0.0001obtained abs = 6.92424e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.299546; expected ratio = 0.001obtained abs = 156.631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815980e+05 Mflops = 348.59 -Solve time = 0.00 -Solve flops = 1.677600e+04 Mflops = 478.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.52222; expected ratio = 0.0001obtained abs = 8.44045e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.334359; expected ratio = 0.001obtained abs = 176.518; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.863160e+05 Mflops = 347.63 -Solve time = 0.00 -Solve flops = 1.700600e+04 Mflops = 485.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.854424; expected ratio = 0.0001obtained abs = 2.61125e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.393026; expected ratio = 0.001obtained abs = 183.153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839660e+05 Mflops = 352.33 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 497.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.643244; expected ratio = 0.0001obtained abs = 4.17049e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.510948; expected ratio = 0.001obtained abs = 333.152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.774040e+05 Mflops = 340.54 -Solve time = 0.00 -Solve flops = 1.653800e+04 Mflops = 499.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.18742; expected ratio = 0.0001obtained abs = 3.72632e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.50582; expected ratio = 0.001obtained abs = 308.016; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.763500e+05 Mflops = 339.76 -Solve time = 0.00 -Solve flops = 1.647000e+04 Mflops = 483.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.657977; expected ratio = 0.0001obtained abs = 1.29976e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.33165; expected ratio = 0.001obtained abs = 176.767; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.863880e+05 Mflops = 350.25 -Solve time = 0.00 -Solve flops = 1.697200e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.578628; expected ratio = 0.0001obtained abs = 1.81784e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.2653; expected ratio = 0.001obtained abs = 144.423; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.782860e+05 Mflops = 342.86 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 487.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.563137; expected ratio = 0.0001obtained abs = 1.69283e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.360956; expected ratio = 0.001obtained abs = 223.07; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.806360e+05 Mflops = 346.59 -Solve time = 0.00 -Solve flops = 1.665200e+04 Mflops = 491.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.703513; expected ratio = 0.0001obtained abs = 1.86677e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.290389; expected ratio = 0.001obtained abs = 165.864; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.824220e+05 Mflops = 350.82 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 372.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.883362; expected ratio = 0.0001obtained abs = 1.85636e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.360066; expected ratio = 0.001obtained abs = 196.642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.807740e+05 Mflops = 344.96 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 492.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.90469; expected ratio = 0.0001obtained abs = 1.14881e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.26221; expected ratio = 0.001obtained abs = 137.199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811600e+05 Mflops = 347.59 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 481.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.575853; expected ratio = 0.0001obtained abs = 1.35874e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.327172; expected ratio = 0.001obtained abs = 182.711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845180e+05 Mflops = 353.55 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 493.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.405491; expected ratio = 0.0001obtained abs = 9.04038e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.259325; expected ratio = 0.001obtained abs = 151.909; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.804840e+05 Mflops = 346.46 -Solve time = 0.00 -Solve flops = 1.666600e+04 Mflops = 488.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.274109; expected ratio = 0.0001obtained abs = 5.50014e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.212607; expected ratio = 0.001obtained abs = 120.96; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.783240e+05 Mflops = 343.57 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 486.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.247296; expected ratio = 0.0001obtained abs = 5.34009e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249697; expected ratio = 0.001obtained abs = 133.607; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.3961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.52464 - Final Residual ratio : 0.00297731 - Residual ratio : 0.000844712 - Slope : -0.125774 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.9166 - Final Residual ratio : 0.00254714 - Residual ratio : 0.000873325 - Slope : -0.104073 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.44396 - Final Residual ratio : 0.00174438 - Residual ratio : 0.000713749 - Slope : -0.0872221 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.3991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.09603 - Final Residual ratio : 0.00188927 - Residual ratio : 0.000901355 - Slope : -0.0872558 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.3991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 30 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.96142 - Final Residual ratio : 0.00141716 - Residual ratio : 0.000722517 - Slope : -0.0816668 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64628 - Final Residual ratio : 0.00159643 - Residual ratio : 0.000969721 - Slope : -0.0685284 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48049 - Final Residual ratio : 0.00130064 - Residual ratio : 0.000878523 - Slope : -0.0616328 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3882 - Final Residual ratio : 0.0112193 - Residual ratio : 0.000684598 - Slope : -0.744407 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.0156 - Final Residual ratio : 0.00526362 - Residual ratio : 0.000656672 - Slope : -0.348275 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4051 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 30 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.28616 - Final Residual ratio : 0.00218404 - Residual ratio : 0.00095533 - Slope : -0.0993034 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.830900e+05 Mflops = 350.82 -Solve time = 0.00 -Solve flops = 1.676000e+04 Mflops = 478.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.271737; expected ratio = 0.0001obtained abs = 5.50104e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.20909; expected ratio = 0.001obtained abs = 113.044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.779460e+05 Mflops = 342.21 -Solve time = 0.00 -Solve flops = 1.654000e+04 Mflops = 488.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.177363; expected ratio = 0.0001obtained abs = 3.3102e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.147204; expected ratio = 0.001obtained abs = 82.9713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.799800e+05 Mflops = 346.12 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 491.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.41898; expected ratio = 0.0001obtained abs = 6.42617e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.285685; expected ratio = 0.001obtained abs = 150.477; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859540e+05 Mflops = 352.12 -Solve time = 0.00 -Solve flops = 1.688800e+04 Mflops = 498.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.279502; expected ratio = 0.0001obtained abs = 4.59526e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.214157; expected ratio = 0.001obtained abs = 107.627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.840020e+05 Mflops = 344.54 -Solve time = 0.00 -Solve flops = 1.680000e+04 Mflops = 479.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.250002; expected ratio = 0.0001obtained abs = 4.23835e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185405; expected ratio = 0.001obtained abs = 94.5497; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.798500e+05 Mflops = 344.61 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 488.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.320669; expected ratio = 0.0001obtained abs = 4.90911e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0994445; expected ratio = 0.001obtained abs = 52.9761; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.794700e+05 Mflops = 345.14 -Solve time = 0.00 -Solve flops = 1.664400e+04 Mflops = 478.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.344654; expected ratio = 0.0001obtained abs = 4.41477e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.244739; expected ratio = 0.001obtained abs = 120.581; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838800e+05 Mflops = 353.62 -Solve time = 0.00 -Solve flops = 1.685000e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.345444; expected ratio = 0.0001obtained abs = 4.92305e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.238764; expected ratio = 0.001obtained abs = 117.566; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847460e+05 Mflops = 353.99 -Solve time = 0.00 -Solve flops = 1.690200e+04 Mflops = 482.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.291711; expected ratio = 0.0001obtained abs = 4.94832e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.204002; expected ratio = 0.001obtained abs = 104.531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.799300e+05 Mflops = 340.71 -Solve time = 0.00 -Solve flops = 1.667000e+04 Mflops = 488.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.520387; expected ratio = 0.0001obtained abs = 1.2211e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.219379; expected ratio = 0.001obtained abs = 122.605; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792080e+05 Mflops = 341.97 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 474.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.235477; expected ratio = 0.0001obtained abs = 5.95982e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.205217; expected ratio = 0.001obtained abs = 118.912; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.830120e+05 Mflops = 348.60 -Solve time = 0.00 -Solve flops = 1.676800e+04 Mflops = 495.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.344111; expected ratio = 0.0001obtained abs = 1.15062e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.281394; expected ratio = 0.001obtained abs = 167.007; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834180e+05 Mflops = 351.44 -Solve time = 0.00 -Solve flops = 1.679800e+04 Mflops = 492.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.730041; expected ratio = 0.0001obtained abs = 1.53063e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.271055; expected ratio = 0.001obtained abs = 159.131; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.792920e+05 Mflops = 344.17 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 474.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.572824; expected ratio = 0.0001obtained abs = 8.09188e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.329159; expected ratio = 0.001obtained abs = 176.595; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814960e+05 Mflops = 347.13 -Solve time = 0.00 -Solve flops = 1.671800e+04 Mflops = 490.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.346279; expected ratio = 0.0001obtained abs = 4.8488e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.374942; expected ratio = 0.001obtained abs = 188.061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856560e+05 Mflops = 355.57 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 498.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.444168; expected ratio = 0.0001obtained abs = 8.75888e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.296687; expected ratio = 0.001obtained abs = 155.859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855840e+05 Mflops = 349.53 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 482.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.308682; expected ratio = 0.0001obtained abs = 6.80998e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.272754; expected ratio = 0.001obtained abs = 154.176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.813480e+05 Mflops = 347.48 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 489.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.567839; expected ratio = 0.0001obtained abs = 8.52278e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.286782; expected ratio = 0.001obtained abs = 158.885; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.815240e+05 Mflops = 347.02 -Solve time = 0.00 -Solve flops = 1.671200e+04 Mflops = 493.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.300746; expected ratio = 0.0001obtained abs = 4.33583e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.302634; expected ratio = 0.001obtained abs = 156.937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.862640e+05 Mflops = 356.73 -Solve time = 0.00 -Solve flops = 1.692600e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.42337; expected ratio = 0.0001obtained abs = 8.3465e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.274577; expected ratio = 0.001obtained abs = 141.317; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.19066 - Final Residual ratio : 0.00211232 - Residual ratio : 0.00096424 - Slope : -0.084175 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.01026 - Final Residual ratio : 0.00159875 - Residual ratio : 0.000795296 - Slope : -0.0743948 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75497 - Final Residual ratio : 0.00145471 - Residual ratio : 0.000828908 - Slope : -0.0649448 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4857 - Final Residual ratio : 0.00118698 - Residual ratio : 0.000798936 - Slope : -0.0549819 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 30 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5159 - Final Residual ratio : 0.00104208 - Residual ratio : 0.000687436 - Slope : -0.0631189 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11419 - Final Residual ratio : 0.000637247 - Residual ratio : 0.000571936 - Slope : -0.0463982 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.28641 - Final Residual ratio : 0.00476989 - Residual ratio : 0.000902294 - Slope : -0.440136 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.442 - Final Residual ratio : 0.0204266 - Residual ratio : 0.000835716 - Slope : -1.01757 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.75405 - Final Residual ratio : 0.00461524 - Residual ratio : 0.000970802 - Slope : -0.175905 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.4151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 31 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.82362 - Final Residual ratio : 0.00439962 - Residual ratio : 0.000755478 - Slope : -0.200663 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.852680e+05 Mflops = 343.84 -Solve time = 0.00 -Solve flops = 1.684000e+04 Mflops = 480.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.41568; expected ratio = 0.0001obtained abs = 1.22289e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.331025; expected ratio = 0.001obtained abs = 192.631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.891340e+05 Mflops = 351.48 -Solve time = 0.00 -Solve flops = 1.703000e+04 Mflops = 485.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.35571; expected ratio = 0.0001obtained abs = 8.67074e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.346301; expected ratio = 0.001obtained abs = 214.785; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.814640e+05 Mflops = 342.38 -Solve time = 0.00 -Solve flops = 1.671000e+04 Mflops = 493.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.841367; expected ratio = 0.0001obtained abs = 1.19222e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.383853; expected ratio = 0.001obtained abs = 203.746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.819940e+05 Mflops = 346.66 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 477.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.327289; expected ratio = 0.0001obtained abs = 4.25705e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242659; expected ratio = 0.001obtained abs = 121.62; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.850280e+05 Mflops = 351.80 -Solve time = 0.00 -Solve flops = 1.686000e+04 Mflops = 498.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.344956; expected ratio = 0.0001obtained abs = 5.483e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.306791; expected ratio = 0.001obtained abs = 158.008; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.855820e+05 Mflops = 353.49 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.500774; expected ratio = 0.0001obtained abs = 1.1473e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.377135; expected ratio = 0.001obtained abs = 213.691; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.783200e+05 Mflops = 341.05 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 487.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.507287; expected ratio = 0.0001obtained abs = 1.08878e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.312258; expected ratio = 0.001obtained abs = 178.296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.772920e+05 Mflops = 339.09 -Solve time = 0.00 -Solve flops = 1.654600e+04 Mflops = 472.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.276219; expected ratio = 0.0001obtained abs = 6.14563e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.29966; expected ratio = 0.001obtained abs = 160.1; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.838020e+05 Mflops = 350.74 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.369327; expected ratio = 0.0001obtained abs = 8.11352e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.205667; expected ratio = 0.001obtained abs = 116.29; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.837180e+05 Mflops = 345.86 -Solve time = 0.00 -Solve flops = 1.687200e+04 Mflops = 484.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.988154; expected ratio = 0.0001obtained abs = 0.000209176; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.432478; expected ratio = 0.001obtained abs = 314.214; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.746640e+05 Mflops = 335.28 -Solve time = 0.00 -Solve flops = 1.641200e+04 Mflops = 481.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.23967; expected ratio = 0.0001obtained abs = 0.000167581; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.750127; expected ratio = 0.001obtained abs = 454.363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841980e+05 Mflops = 348.80 -Solve time = 0.00 -Solve flops = 1.687200e+04 Mflops = 494.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.09128; expected ratio = 0.0001obtained abs = 3.80883e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.711543; expected ratio = 0.001obtained abs = 364.188; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.866940e+05 Mflops = 352.88 -Solve time = 0.00 -Solve flops = 1.694200e+04 Mflops = 483.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.369855; expected ratio = 0.0001obtained abs = 1.22041e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.29113; expected ratio = 0.001obtained abs = 161.165; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.795000e+05 Mflops = 340.67 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 487.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.486967; expected ratio = 0.0001obtained abs = 1.18229e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.196136; expected ratio = 0.001obtained abs = 112.3; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.796180e+05 Mflops = 343.54 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 474.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.458703; expected ratio = 0.0001obtained abs = 1.07927e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.356779; expected ratio = 0.001obtained abs = 204.725; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.851780e+05 Mflops = 352.72 -Solve time = 0.00 -Solve flops = 1.685600e+04 Mflops = 494.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.359927; expected ratio = 0.0001obtained abs = 1.00771e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.313706; expected ratio = 0.001obtained abs = 167.019; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.853660e+05 Mflops = 353.08 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 498.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.413714; expected ratio = 0.0001obtained abs = 1.36718e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.304708; expected ratio = 0.001obtained abs = 173.798; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.771880e+05 Mflops = 340.13 -Solve time = 0.00 -Solve flops = 1.649800e+04 Mflops = 487.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.03736; expected ratio = 0.0001obtained abs = 4.08622e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.303271; expected ratio = 0.001obtained abs = 164.084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.811180e+05 Mflops = 334.21 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 489.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.21342; expected ratio = 0.0001obtained abs = 3.66399e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.41302; expected ratio = 0.001obtained abs = 215.295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.869240e+05 Mflops = 354.76 -Solve time = 0.00 -Solve flops = 1.694800e+04 Mflops = 497.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.392081; expected ratio = 0.0001obtained abs = 7.14574e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.292415; expected ratio = 0.001obtained abs = 157.304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.85564 - Final Residual ratio : 0.00479614 - Residual ratio : 0.000987745 - Slope : -0.173245 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.09508 - Final Residual ratio : 0.00284612 - Residual ratio : 0.000695009 - Slope : -0.141111 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.34655 - Final Residual ratio : 0.0030101 - Residual ratio : 0.000899463 - Slope : -0.119412 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.74972 - Final Residual ratio : 0.00238277 - Residual ratio : 0.00086655 - Slope : -0.105667 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 31 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.44597 - Final Residual ratio : 0.00137821 - Residual ratio : 0.00056346 - Slope : -0.101858 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05247 - Final Residual ratio : 0.00179953 - Residual ratio : 0.000876764 - Slope : -0.0854445 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.86724 - Final Residual ratio : 0.00155832 - Residual ratio : 0.000834558 - Slope : -0.0746274 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.71324 - Final Residual ratio : 0.00149188 - Residual ratio : 0.000870799 - Slope : -0.0713226 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56745 - Final Residual ratio : 0.00141355 - Residual ratio : 0.000901819 - Slope : -0.0680883 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 31 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5828 - Final Residual ratio : 0.00107185 - Residual ratio : 0.000677189 - Slope : -0.0659051 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.844800e+05 Mflops = 354.13 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 497.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.307177; expected ratio = 0.0001obtained abs = 7.07873e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249366; expected ratio = 0.001obtained abs = 136.619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841220e+05 Mflops = 353.44 -Solve time = 0.00 -Solve flops = 1.683800e+04 Mflops = 480.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.221638; expected ratio = 0.0001obtained abs = 4.9422e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.273119; expected ratio = 0.001obtained abs = 160.455; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.797860e+05 Mflops = 345.75 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 487.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.394429; expected ratio = 0.0001obtained abs = 1.14608e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.396979; expected ratio = 0.001obtained abs = 229.836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.844420e+05 Mflops = 355.35 -Solve time = 0.00 -Solve flops = 1.685000e+04 Mflops = 480.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.37956; expected ratio = 0.0001obtained abs = 1.26854e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.391859; expected ratio = 0.001obtained abs = 226.043; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.854600e+05 Mflops = 357.97 -Solve time = 0.00 -Solve flops = 1.690000e+04 Mflops = 482.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.33966; expected ratio = 0.0001obtained abs = 1.57597e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.282041; expected ratio = 0.001obtained abs = 181.226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.779900e+05 Mflops = 343.55 -Solve time = 0.00 -Solve flops = 1.660600e+04 Mflops = 487.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.986357; expected ratio = 0.0001obtained abs = 0.000210805; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.370321; expected ratio = 0.001obtained abs = 238.416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.822300e+05 Mflops = 351.74 -Solve time = 0.00 -Solve flops = 1.677600e+04 Mflops = 495.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.2224; expected ratio = 0.0001obtained abs = 0.000159795; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.333402; expected ratio = 0.001obtained abs = 199.307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.839760e+05 Mflops = 351.71 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 497.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.715619; expected ratio = 0.0001obtained abs = 3.93451e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.393422; expected ratio = 0.001obtained abs = 281.784; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.810780e+05 Mflops = 346.80 -Solve time = 0.00 -Solve flops = 1.671600e+04 Mflops = 476.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.300361; expected ratio = 0.0001obtained abs = 1.79608e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.546201; expected ratio = 0.001obtained abs = 316.937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.852900e+05 Mflops = 355.68 -Solve time = 0.00 -Solve flops = 1.687000e+04 Mflops = 494.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.275857; expected ratio = 0.0001obtained abs = 1.82658e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.392712; expected ratio = 0.001obtained abs = 237.537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.836020e+05 Mflops = 353.74 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 496.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.257041; expected ratio = 0.0001obtained abs = 2.14937e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.30887; expected ratio = 0.001obtained abs = 215.538; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.789280e+05 Mflops = 344.73 -Solve time = 0.00 -Solve flops = 1.660600e+04 Mflops = 487.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.330385; expected ratio = 0.0001obtained abs = 2.86279e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.542031; expected ratio = 0.001obtained abs = 311.197; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.871340e+05 Mflops = 358.40 -Solve time = 0.00 -Solve flops = 1.699600e+04 Mflops = 484.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.289782; expected ratio = 0.0001obtained abs = 3.06447e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.470043; expected ratio = 0.001obtained abs = 286.843; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834460e+05 Mflops = 354.90 -Solve time = 0.00 -Solve flops = 1.682600e+04 Mflops = 480.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.323494; expected ratio = 0.0001obtained abs = 3.78424e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.495844; expected ratio = 0.001obtained abs = 388.408; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.834820e+05 Mflops = 347.44 -Solve time = 0.00 -Solve flops = 1.676000e+04 Mflops = 495.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.465566; expected ratio = 0.0001obtained abs = 4.69603e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.0441; expected ratio = 0.001obtained abs = 568.04; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.882700e+05 Mflops = 356.67 -Solve time = 0.00 -Solve flops = 1.704800e+04 Mflops = 486.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.310618; expected ratio = 0.0001obtained abs = 4.02069e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.794866; expected ratio = 0.001obtained abs = 570.209; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.853080e+05 Mflops = 356.37 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 481.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.334701; expected ratio = 0.0001obtained abs = 5.48229e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.998742; expected ratio = 0.001obtained abs = 626.358; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847440e+05 Mflops = 354.63 -Solve time = 0.00 -Solve flops = 1.688000e+04 Mflops = 481.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.26852; expected ratio = 0.0001obtained abs = 4.57234e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.712737; expected ratio = 0.001obtained abs = 406.727; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.883720e+05 Mflops = 357.51 -Solve time = 0.00 -Solve flops = 1.705400e+04 Mflops = 486.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.301566; expected ratio = 0.0001obtained abs = 6.87667e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.46414; expected ratio = 0.001obtained abs = 250.172; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.874260e+05 Mflops = 358.31 -Solve time = 0.00 -Solve flops = 1.703000e+04 Mflops = 499.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.275698; expected ratio = 0.0001obtained abs = 6.56962e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.464221; expected ratio = 0.001obtained abs = 293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2789 - Final Residual ratio : 0.00111262 - Residual ratio : 0.000869978 - Slope : -0.0511116 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15204 - Final Residual ratio : 0.000888456 - Residual ratio : 0.000771202 - Slope : -0.0426352 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.5868 - Final Residual ratio : 0.0178245 - Residual ratio : 0.000910024 - Slope : -0.724777 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.3112 - Final Residual ratio : 0.0211916 - Residual ratio : 0.000949818 - Slope : -0.857309 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.55042 - Final Residual ratio : 0.00816198 - Residual ratio : 0.000854619 - Slope : -0.68159 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.42402 - Final Residual ratio : 0.0035751 - Residual ratio : 0.000659124 - Slope : -0.180681 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.51102 - Final Residual ratio : 0.00268403 - Residual ratio : 0.000594995 - Slope : -0.150278 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.89865 - Final Residual ratio : 0.00357355 - Residual ratio : 0.000916613 - Slope : -0.134313 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11727 - Final Residual ratio : 0.0022729 - Residual ratio : 0.000729131 - Slope : -0.103833 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.46208 - Final Residual ratio : 0.00192514 - Residual ratio : 0.000781913 - Slope : -0.084833 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.881260e+05 Mflops = 349.60 -Solve time = 0.00 -Solve flops = 1.698800e+04 Mflops = 471.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.421813; expected ratio = 0.0001obtained abs = 0.000154803; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.320775; expected ratio = 0.001obtained abs = 206.441; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.843540e+05 Mflops = 353.24 -Solve time = 0.00 -Solve flops = 1.688800e+04 Mflops = 495.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.26602; expected ratio = 0.0001obtained abs = 0.000128996; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.736478; expected ratio = 0.001obtained abs = 374.405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.849600e+05 Mflops = 355.05 -Solve time = 0.00 -Solve flops = 1.689800e+04 Mflops = 482.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.230839; expected ratio = 0.0001obtained abs = 0.000127386; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.841669; expected ratio = 0.001obtained abs = 671.63; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.841380e+05 Mflops = 351.54 -Solve time = 0.00 -Solve flops = 1.684000e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.189082; expected ratio = 0.0001obtained abs = 0.000104411; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.52739; expected ratio = 0.001obtained abs = 1082.62; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.871520e+05 Mflops = 349.19 -Solve time = 0.00 -Solve flops = 1.696600e+04 Mflops = 497.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.201437; expected ratio = 0.0001obtained abs = 0.000126109; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.56349; expected ratio = 0.001obtained abs = 846.431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.903600e+05 Mflops = 361.12 -Solve time = 0.00 -Solve flops = 1.711200e+04 Mflops = 488.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.120882; expected ratio = 0.0001obtained abs = 7.67698e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.724401; expected ratio = 0.001obtained abs = 369.091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.826460e+05 Mflops = 348.53 -Solve time = 0.00 -Solve flops = 1.679800e+04 Mflops = 496.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.135027; expected ratio = 0.0001obtained abs = 9.44842e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.811076; expected ratio = 0.001obtained abs = 381.329; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.920640e+05 Mflops = 364.51 -Solve time = 0.00 -Solve flops = 1.721000e+04 Mflops = 491.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.141364; expected ratio = 0.0001obtained abs = 0.00010617; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.903361; expected ratio = 0.001obtained abs = 417.51; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.915240e+05 Mflops = 363.49 -Solve time = 0.00 -Solve flops = 1.715200e+04 Mflops = 503.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0654891; expected ratio = 0.0001obtained abs = 4.68911e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.676995; expected ratio = 0.001obtained abs = 329.902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.902220e+05 Mflops = 361.51 -Solve time = 0.00 -Solve flops = 1.710600e+04 Mflops = 491.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0834248; expected ratio = 0.0001obtained abs = 6.27328e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.837589; expected ratio = 0.001obtained abs = 377.894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944080e+05 Mflops = 367.47 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 496.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0947739; expected ratio = 0.0001obtained abs = 7.41159e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.748668; expected ratio = 0.001obtained abs = 326.924; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.917520e+05 Mflops = 355.87 -Solve time = 0.00 -Solve flops = 1.716400e+04 Mflops = 489.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0632589; expected ratio = 0.0001obtained abs = 4.69963e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.354931; expected ratio = 0.001obtained abs = 159.154; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.901800e+05 Mflops = 360.94 -Solve time = 0.00 -Solve flops = 1.710400e+04 Mflops = 488.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0709225; expected ratio = 0.0001obtained abs = 5.41106e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.407451; expected ratio = 0.001obtained abs = 173.778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.919620e+05 Mflops = 365.64 -Solve time = 0.00 -Solve flops = 1.720400e+04 Mflops = 490.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0784735; expected ratio = 0.0001obtained abs = 6.1978e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.464973; expected ratio = 0.001obtained abs = 193.182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.942040e+05 Mflops = 367.74 -Solve time = 0.00 -Solve flops = 1.728000e+04 Mflops = 493.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0578398; expected ratio = 0.0001obtained abs = 4.34861e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.344758; expected ratio = 0.001obtained abs = 156.974; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.901800e+05 Mflops = 361.59 -Solve time = 0.00 -Solve flops = 1.710400e+04 Mflops = 488.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0625982; expected ratio = 0.0001obtained abs = 4.80594e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.453882; expected ratio = 0.001obtained abs = 186.934; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943060e+05 Mflops = 369.44 -Solve time = 0.00 -Solve flops = 1.728600e+04 Mflops = 493.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0699449; expected ratio = 0.0001obtained abs = 5.54593e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.418424; expected ratio = 0.001obtained abs = 176.639; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.942040e+05 Mflops = 368.41 -Solve time = 0.00 -Solve flops = 1.728000e+04 Mflops = 496.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.057813; expected ratio = 0.0001obtained abs = 4.36817e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.219033; expected ratio = 0.001obtained abs = 96.9021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.902820e+05 Mflops = 356.29 -Solve time = 0.00 -Solve flops = 1.711000e+04 Mflops = 488.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0642508; expected ratio = 0.0001obtained abs = 4.93148e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.305276; expected ratio = 0.001obtained abs = 128.642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943060e+05 Mflops = 369.27 -Solve time = 0.00 -Solve flops = 1.728600e+04 Mflops = 480.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0722114; expected ratio = 0.0001obtained abs = 5.74736e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.369257; expected ratio = 0.001obtained abs = 151.898; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5194 - Final Residual ratio : 0.00141074 - Residual ratio : 0.000928485 - Slope : -0.108428 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01028 - Final Residual ratio : 0.000625906 - Residual ratio : 0.000619536 - Slope : -0.0360592 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.868195 - Final Residual ratio : 0.000764446 - Residual ratio : 0.0008805 - Slope : -0.0299114 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.892584 - Final Residual ratio : 0.000641273 - Residual ratio : 0.000718446 - Slope : -0.0297314 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03369 - Final Residual ratio : 0.00070268 - Residual ratio : 0.000679781 - Slope : -0.0344328 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.758918 - Final Residual ratio : 0.000490473 - Residual ratio : 0.00064628 - Slope : -0.0252809 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.60121 - Final Residual ratio : 0.00051875 - Residual ratio : 0.000862844 - Slope : -0.0214533 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.472638 - Final Residual ratio : 0.000385914 - Residual ratio : 0.00081651 - Slope : -0.0168662 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.433198 - Final Residual ratio : 0.000322095 - Residual ratio : 0.000743529 - Slope : -0.0144292 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.946892 - Final Residual ratio : 0.000712594 - Residual ratio : 0.000752561 - Slope : -0.0337921 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.942040e+05 Mflops = 367.08 -Solve time = 0.00 -Solve flops = 1.728000e+04 Mflops = 479.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.435589; expected ratio = 0.0001obtained abs = 0.000608681; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.420993; expected ratio = 0.001obtained abs = 237.798; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831120e+05 Mflops = 352.14 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.108383; expected ratio = 0.0001obtained abs = 0.000149127; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.694792; expected ratio = 0.001obtained abs = 347.375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.896040e+05 Mflops = 361.81 -Solve time = 0.00 -Solve flops = 1.708600e+04 Mflops = 487.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.103945; expected ratio = 0.0001obtained abs = 0.000152652; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.680992; expected ratio = 0.001obtained abs = 288.502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.971480e+05 Mflops = 367.02 -Solve time = 0.00 -Solve flops = 1.739400e+04 Mflops = 496.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0648695; expected ratio = 0.0001obtained abs = 9.49613e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.320861; expected ratio = 0.001obtained abs = 152.836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.884660e+05 Mflops = 360.95 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 502.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0779214; expected ratio = 0.0001obtained abs = 0.000113003; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.367852; expected ratio = 0.001obtained abs = 165.725; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.915240e+05 Mflops = 366.14 -Solve time = 0.00 -Solve flops = 1.715200e+04 Mflops = 489.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0784824; expected ratio = 0.0001obtained abs = 0.000119708; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.410504; expected ratio = 0.001obtained abs = 166.13; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941960e+05 Mflops = 368.39 -Solve time = 0.00 -Solve flops = 1.729600e+04 Mflops = 510.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.166194; expected ratio = 0.0001obtained abs = 0.000250016; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.335899; expected ratio = 0.001obtained abs = 156.43; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.873260e+05 Mflops = 359.42 -Solve time = 0.00 -Solve flops = 1.698000e+04 Mflops = 487.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0959863; expected ratio = 0.0001obtained abs = 0.000143588; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.471519; expected ratio = 0.001obtained abs = 204.78; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.936100e+05 Mflops = 363.17 -Solve time = 0.00 -Solve flops = 1.729000e+04 Mflops = 493.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0831087; expected ratio = 0.0001obtained abs = 0.000128673; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.457768; expected ratio = 0.001obtained abs = 183.815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.903160e+05 Mflops = 362.51 -Solve time = 0.00 -Solve flops = 1.714200e+04 Mflops = 489.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0631108; expected ratio = 0.0001obtained abs = 9.39787e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242911; expected ratio = 0.001obtained abs = 109.027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.891200e+05 Mflops = 361.54 -Solve time = 0.00 -Solve flops = 1.706800e+04 Mflops = 487.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0579675; expected ratio = 0.0001obtained abs = 8.69148e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.292415; expected ratio = 0.001obtained abs = 122.259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.910520e+05 Mflops = 363.91 -Solve time = 0.00 -Solve flops = 1.715200e+04 Mflops = 489.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0571462; expected ratio = 0.0001obtained abs = 8.86303e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.263902; expected ratio = 0.001obtained abs = 105.56; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.903740e+05 Mflops = 363.28 -Solve time = 0.00 -Solve flops = 1.714600e+04 Mflops = 489.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0566865; expected ratio = 0.0001obtained abs = 8.47974e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189227; expected ratio = 0.001obtained abs = 83.5186; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.894440e+05 Mflops = 361.50 -Solve time = 0.00 -Solve flops = 1.708600e+04 Mflops = 487.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0544047; expected ratio = 0.0001obtained abs = 8.16044e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.264886; expected ratio = 0.001obtained abs = 112.325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.909500e+05 Mflops = 363.06 -Solve time = 0.00 -Solve flops = 1.714600e+04 Mflops = 502.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0530965; expected ratio = 0.0001obtained abs = 8.23603e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.258772; expected ratio = 0.001obtained abs = 102.206; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.900140e+05 Mflops = 354.53 -Solve time = 0.00 -Solve flops = 1.712600e+04 Mflops = 427.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0591419; expected ratio = 0.0001obtained abs = 8.87604e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.216156; expected ratio = 0.001obtained abs = 95.5825; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.893420e+05 Mflops = 362.13 -Solve time = 0.00 -Solve flops = 1.708000e+04 Mflops = 487.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0523352; expected ratio = 0.0001obtained abs = 7.83252e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.256494; expected ratio = 0.001obtained abs = 108.063; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.909940e+05 Mflops = 365.79 -Solve time = 0.00 -Solve flops = 1.714800e+04 Mflops = 489.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0514305; expected ratio = 0.0001obtained abs = 7.98621e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.202459; expected ratio = 0.001obtained abs = 80.1303; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.903740e+05 Mflops = 363.28 -Solve time = 0.00 -Solve flops = 1.714600e+04 Mflops = 489.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0597935; expected ratio = 0.0001obtained abs = 9.01157e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.18753; expected ratio = 0.001obtained abs = 81.7757; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.909740e+05 Mflops = 363.76 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0483151; expected ratio = 0.0001obtained abs = 7.23593e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.228355; expected ratio = 0.001obtained abs = 97.0831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.538128 - Final Residual ratio : 0.00052024 - Residual ratio : 0.000966759 - Slope : -0.0268804 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.547395 - Final Residual ratio : 0.000483773 - Residual ratio : 0.000883773 - Slope : -0.0195326 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.536785 - Final Residual ratio : 0.000434281 - Residual ratio : 0.000809042 - Slope : -0.0198648 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.509444 - Final Residual ratio : 0.000371682 - Residual ratio : 0.000729583 - Slope : -0.0181812 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.943611 - Final Residual ratio : 0.000756541 - Residual ratio : 0.000801751 - Slope : -0.0325122 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4511 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.463377 - Final Residual ratio : 0.000412309 - Residual ratio : 0.000889792 - Slope : -0.0159643 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.432971 - Final Residual ratio : 0.000432638 - Residual ratio : 0.000999231 - Slope : -0.0149151 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4531 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.418973 - Final Residual ratio : 0.000254075 - Residual ratio : 0.000606423 - Slope : -0.0139573 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.415748 - Final Residual ratio : 0.000329416 - Residual ratio : 0.000792346 - Slope : -0.0143248 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.883645 - Final Residual ratio : 0.000673501 - Residual ratio : 0.000762185 - Slope : -0.0304473 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.909940e+05 Mflops = 362.48 -Solve time = 0.00 -Solve flops = 1.714800e+04 Mflops = 489.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.359276; expected ratio = 0.0001obtained abs = 0.000824378; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19368; expected ratio = 0.001obtained abs = 85.9116; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.927940e+05 Mflops = 365.90 -Solve time = 0.00 -Solve flops = 1.725200e+04 Mflops = 492.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0648539; expected ratio = 0.0001obtained abs = 0.000142529; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.128224; expected ratio = 0.001obtained abs = 59.8197; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.890300e+05 Mflops = 360.88 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 501.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0312628; expected ratio = 0.0001obtained abs = 6.89643e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.213365; expected ratio = 0.001obtained abs = 93.0236; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.907640e+05 Mflops = 363.36 -Solve time = 0.00 -Solve flops = 1.716400e+04 Mflops = 503.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0388879; expected ratio = 0.0001obtained abs = 8.831e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185305; expected ratio = 0.001obtained abs = 74.9748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.924580e+05 Mflops = 353.74 -Solve time = 0.00 -Solve flops = 1.724000e+04 Mflops = 491.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.040421; expected ratio = 0.0001obtained abs = 9.09237e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.163822; expected ratio = 0.001obtained abs = 71.1348; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000645876 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932700e+05 Mflops = 365.48 -Solve time = 0.00 -Solve flops = 1.725400e+04 Mflops = 492.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0314834; expected ratio = 0.0001obtained abs = 7.04871e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.173631; expected ratio = 0.001obtained abs = 75.2082; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.940180e+05 Mflops = 367.39 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 493.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0285272; expected ratio = 0.0001obtained abs = 6.52069e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164837; expected ratio = 0.001obtained abs = 66.4905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00048399 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.931660e+05 Mflops = 367.94 -Solve time = 0.00 -Solve flops = 1.724800e+04 Mflops = 492.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0341728; expected ratio = 0.0001obtained abs = 7.74694e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.169699; expected ratio = 0.001obtained abs = 72.6175; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.931960e+05 Mflops = 367.33 -Solve time = 0.00 -Solve flops = 1.725000e+04 Mflops = 492.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0241174; expected ratio = 0.0001obtained abs = 5.42748e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.149512; expected ratio = 0.001obtained abs = 64.0277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.939060e+05 Mflops = 366.52 -Solve time = 0.00 -Solve flops = 1.728400e+04 Mflops = 493.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.023436; expected ratio = 0.0001obtained abs = 5.35897e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.115335; expected ratio = 0.001obtained abs = 46.8007; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.928660e+05 Mflops = 366.70 -Solve time = 0.00 -Solve flops = 1.723000e+04 Mflops = 491.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0289215; expected ratio = 0.0001obtained abs = 6.58146e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.124756; expected ratio = 0.001obtained abs = 52.4736; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.935980e+05 Mflops = 357.87 -Solve time = 0.00 -Solve flops = 1.727400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0195038; expected ratio = 0.0001obtained abs = 4.40085e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107023; expected ratio = 0.001obtained abs = 45.7155; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932700e+05 Mflops = 362.70 -Solve time = 0.00 -Solve flops = 1.725400e+04 Mflops = 492.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.019635; expected ratio = 0.0001obtained abs = 4.48589e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0991327; expected ratio = 0.001obtained abs = 40.3292; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.931660e+05 Mflops = 367.94 -Solve time = 0.00 -Solve flops = 1.724800e+04 Mflops = 492.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0223897; expected ratio = 0.0001obtained abs = 5.10482e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.115142; expected ratio = 0.001obtained abs = 48.0653; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.928500e+05 Mflops = 365.84 -Solve time = 0.00 -Solve flops = 1.723000e+04 Mflops = 494.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0147944; expected ratio = 0.0001obtained abs = 3.34404e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0842101; expected ratio = 0.001obtained abs = 35.7957; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.929100e+05 Mflops = 367.45 -Solve time = 0.00 -Solve flops = 1.723400e+04 Mflops = 491.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0173646; expected ratio = 0.0001obtained abs = 3.96049e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0783999; expected ratio = 0.001obtained abs = 32.1278; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.935540e+05 Mflops = 367.34 -Solve time = 0.00 -Solve flops = 1.727200e+04 Mflops = 506.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0188175; expected ratio = 0.0001obtained abs = 4.29533e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0987413; expected ratio = 0.001obtained abs = 40.9199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.936900e+05 Mflops = 366.94 -Solve time = 0.00 -Solve flops = 1.727200e+04 Mflops = 492.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0131094; expected ratio = 0.0001obtained abs = 2.96567e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0736572; expected ratio = 0.001obtained abs = 31.2933; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.936580e+05 Mflops = 359.25 -Solve time = 0.00 -Solve flops = 1.727800e+04 Mflops = 492.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0158681; expected ratio = 0.0001obtained abs = 3.61489e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105388; expected ratio = 0.001obtained abs = 43.3899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.936460e+05 Mflops = 362.11 -Solve time = 0.00 -Solve flops = 1.727000e+04 Mflops = 492.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0157675; expected ratio = 0.0001obtained abs = 3.60139e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109669; expected ratio = 0.001obtained abs = 45.3081; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.441541 - Final Residual ratio : 0.00042904 - Residual ratio : 0.000971687 - Slope : -0.0176445 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.447142 - Final Residual ratio : 0.000423722 - Residual ratio : 0.000947623 - Slope : -0.0171815 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.45512 - Final Residual ratio : 0.000438576 - Residual ratio : 0.000963648 - Slope : -0.0174878 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.459909 - Final Residual ratio : 0.000430337 - Residual ratio : 0.000935701 - Slope : -0.0183791 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.6266 - Final Residual ratio : 0.0231596 - Residual ratio : 0.000838309 - Slope : -1.10414 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.61851 - Final Residual ratio : 0.0063533 - Residual ratio : 0.00083393 - Slope : -0.271863 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4621 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.33981 - Final Residual ratio : 0.00226574 - Residual ratio : 0.000968343 - Slope : -0.146097 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.28886 - Final Residual ratio : 0.0022385 - Residual ratio : 0.000977995 - Slope : -0.095276 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.47934 - Final Residual ratio : 0.0024057 - Residual ratio : 0.000970297 - Slope : -0.103206 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.73207 - Final Residual ratio : 0.00214463 - Residual ratio : 0.000784982 - Slope : -0.113747 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.939580e+05 Mflops = 367.44 -Solve time = 0.00 -Solve flops = 1.729400e+04 Mflops = 493.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.259741; expected ratio = 0.0001obtained abs = 0.000799706; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.213712; expected ratio = 0.001obtained abs = 101.897; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.920180e+05 Mflops = 356.21 -Solve time = 0.00 -Solve flops = 1.722200e+04 Mflops = 494.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0337109; expected ratio = 0.0001obtained abs = 0.000103055; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.324531; expected ratio = 0.001obtained abs = 137.296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.953540e+05 Mflops = 370.09 -Solve time = 0.00 -Solve flops = 1.736200e+04 Mflops = 495.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0411596; expected ratio = 0.0001obtained abs = 0.000128316; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.27825; expected ratio = 0.001obtained abs = 112.101; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.922500e+05 Mflops = 366.86 -Solve time = 0.00 -Solve flops = 1.722000e+04 Mflops = 494.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0223379; expected ratio = 0.0001obtained abs = 6.91211e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.135162; expected ratio = 0.001obtained abs = 57.3497; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.954940e+05 Mflops = 369.52 -Solve time = 0.00 -Solve flops = 1.737000e+04 Mflops = 513.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0307381; expected ratio = 0.0001obtained abs = 9.57381e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.181879; expected ratio = 0.001obtained abs = 73.9204; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.938680e+05 Mflops = 369.27 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 496.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0277787; expected ratio = 0.0001obtained abs = 8.77296e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.187528; expected ratio = 0.001obtained abs = 72.5445; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.929320e+05 Mflops = 367.49 -Solve time = 0.00 -Solve flops = 1.725600e+04 Mflops = 492.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.022494; expected ratio = 0.0001obtained abs = 7.03169e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127195; expected ratio = 0.001obtained abs = 52.4245; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946600e+05 Mflops = 370.78 -Solve time = 0.00 -Solve flops = 1.732800e+04 Mflops = 494.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0219692; expected ratio = 0.0001obtained abs = 6.87749e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146588; expected ratio = 0.001obtained abs = 58.9086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.947020e+05 Mflops = 360.55 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 494.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0172681; expected ratio = 0.0001obtained abs = 5.46053e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.118657; expected ratio = 0.001obtained abs = 45.8278; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.935080e+05 Mflops = 367.09 -Solve time = 0.00 -Solve flops = 1.728800e+04 Mflops = 510.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.018313; expected ratio = 0.0001obtained abs = 5.74814e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0961203; expected ratio = 0.001obtained abs = 38.9045; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000669003 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941920e+05 Mflops = 368.55 -Solve time = 0.00 -Solve flops = 1.729600e+04 Mflops = 493.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0152618; expected ratio = 0.0001obtained abs = 4.7863e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109792; expected ratio = 0.001obtained abs = 44.0421; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.937480e+05 Mflops = 368.38 -Solve time = 0.00 -Solve flops = 1.727600e+04 Mflops = 510.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.011007; expected ratio = 0.0001obtained abs = 3.47858e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0869117; expected ratio = 0.001obtained abs = 33.7173; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.923760e+05 Mflops = 365.60 -Solve time = 0.00 -Solve flops = 1.722400e+04 Mflops = 494.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0130626; expected ratio = 0.0001obtained abs = 4.10851e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0758495; expected ratio = 0.001obtained abs = 30.3635; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.940120e+05 Mflops = 368.88 -Solve time = 0.00 -Solve flops = 1.728600e+04 Mflops = 493.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00932413; expected ratio = 0.0001obtained abs = 2.92935e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.074773; expected ratio = 0.001obtained abs = 29.8615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.940120e+05 Mflops = 369.55 -Solve time = 0.00 -Solve flops = 1.728600e+04 Mflops = 496.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00684184; expected ratio = 0.0001obtained abs = 2.15949e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0483746; expected ratio = 0.001obtained abs = 18.901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.924420e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.722800e+04 Mflops = 478.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00868593; expected ratio = 0.0001obtained abs = 2.7362e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0448906; expected ratio = 0.001obtained abs = 17.8094; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.925380e+05 Mflops = 366.74 -Solve time = 0.00 -Solve flops = 1.723400e+04 Mflops = 491.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00591938; expected ratio = 0.0001obtained abs = 1.86236e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0436417; expected ratio = 0.001obtained abs = 17.381; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944860e+05 Mflops = 369.11 -Solve time = 0.00 -Solve flops = 1.731200e+04 Mflops = 493.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00475988; expected ratio = 0.0001obtained abs = 1.50115e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0289212; expected ratio = 0.001obtained abs = 11.3524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.924420e+05 Mflops = 365.73 -Solve time = 0.00 -Solve flops = 1.722800e+04 Mflops = 508.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00509219; expected ratio = 0.0001obtained abs = 1.60531e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0288735; expected ratio = 0.001obtained abs = 11.4092; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.929160e+05 Mflops = 366.79 -Solve time = 0.00 -Solve flops = 1.725400e+04 Mflops = 492.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00337418; expected ratio = 0.0001obtained abs = 1.06236e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0232551; expected ratio = 0.001obtained abs = 9.22944; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.45658 - Final Residual ratio : 0.00240527 - Residual ratio : 0.000979113 - Slope : -0.122709 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.16336 - Final Residual ratio : 0.00195382 - Residual ratio : 0.00090314 - Slope : -0.0982456 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80335 - Final Residual ratio : 0.00179735 - Residual ratio : 0.000996677 - Slope : -0.0750645 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42675 - Final Residual ratio : 0.00110625 - Residual ratio : 0.00077536 - Slope : -0.0619846 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36603 - Final Residual ratio : 0.00113916 - Residual ratio : 0.00083392 - Slope : -0.0505516 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.838173 - Final Residual ratio : 0.000798017 - Residual ratio : 0.000952091 - Slope : -0.0310139 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4721 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.5314 - Final Residual ratio : 0.0209487 - Residual ratio : 0.000853957 - Slope : -0.980418 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.2222 - Final Residual ratio : 0.0131748 - Residual ratio : 0.000926352 - Slope : -0.592045 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.32496 - Final Residual ratio : 0.0049766 - Residual ratio : 0.00078682 - Slope : -0.243076 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02651 - Final Residual ratio : 0.00172034 - Residual ratio : 0.000848919 - Slope : -0.0843663 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.942280e+05 Mflops = 363.85 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 493.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.230262; expected ratio = 0.0001obtained abs = 0.000939161; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.196055; expected ratio = 0.001obtained abs = 88.0679; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941760e+05 Mflops = 367.03 -Solve time = 0.00 -Solve flops = 1.729400e+04 Mflops = 510.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0289568; expected ratio = 0.0001obtained abs = 0.000115496; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.198695; expected ratio = 0.001obtained abs = 83.3078; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946180e+05 Mflops = 369.36 -Solve time = 0.00 -Solve flops = 1.732000e+04 Mflops = 494.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00912581; expected ratio = 0.0001obtained abs = 3.65442e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0931973; expected ratio = 0.001obtained abs = 38.5136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 366.94 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00831175; expected ratio = 0.0001obtained abs = 3.32767e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0690947; expected ratio = 0.001obtained abs = 28.469; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941760e+05 Mflops = 368.52 -Solve time = 0.00 -Solve flops = 1.729400e+04 Mflops = 493.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00543701; expected ratio = 0.0001obtained abs = 2.1755e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0675942; expected ratio = 0.001obtained abs = 28.0828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 368.11 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00403639; expected ratio = 0.0001obtained abs = 1.61897e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0648305; expected ratio = 0.001obtained abs = 26.3963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 367.77 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00514969; expected ratio = 0.0001obtained abs = 2.06577e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0526833; expected ratio = 0.001obtained abs = 21.7151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944080e+05 Mflops = 367.47 -Solve time = 0.00 -Solve flops = 1.730800e+04 Mflops = 493.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00359545; expected ratio = 0.0001obtained abs = 1.44069e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0382665; expected ratio = 0.001obtained abs = 15.7351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 368.78 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00322362; expected ratio = 0.0001obtained abs = 1.29331e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0311368; expected ratio = 0.001obtained abs = 12.7729; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.952460e+05 Mflops = 369.72 -Solve time = 0.00 -Solve flops = 1.735600e+04 Mflops = 495.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00390866; expected ratio = 0.0001obtained abs = 1.56855e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.031826; expected ratio = 0.001obtained abs = 13.0173; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 367.95 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00296449; expected ratio = 0.0001obtained abs = 1.18873e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0300857; expected ratio = 0.001obtained abs = 12.406; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.947860e+05 Mflops = 369.01 -Solve time = 0.00 -Solve flops = 1.732800e+04 Mflops = 494.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00302551; expected ratio = 0.0001obtained abs = 1.21354e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0259923; expected ratio = 0.001obtained abs = 10.6361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 367.28 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 507.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.002988; expected ratio = 0.0001obtained abs = 1.19921e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0205462; expected ratio = 0.001obtained abs = 8.42649; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.947860e+05 Mflops = 369.01 -Solve time = 0.00 -Solve flops = 1.732800e+04 Mflops = 494.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00250223; expected ratio = 0.0001obtained abs = 1.00351e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0145357; expected ratio = 0.001obtained abs = 5.96871; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 367.95 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 497.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00272421; expected ratio = 0.0001obtained abs = 1.09276e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0138433; expected ratio = 0.001obtained abs = 5.6836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944080e+05 Mflops = 367.47 -Solve time = 0.00 -Solve flops = 1.730800e+04 Mflops = 493.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00247262; expected ratio = 0.0001obtained abs = 9.92197e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142279; expected ratio = 0.001obtained abs = 5.82375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00075984 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 367.95 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 511.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00214274; expected ratio = 0.0001obtained abs = 8.59558e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136745; expected ratio = 0.001obtained abs = 5.6186; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000488043 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 367.95 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00221448; expected ratio = 0.0001obtained abs = 8.88281e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0111488; expected ratio = 0.001obtained abs = 4.5722; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 367.95 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00213741; expected ratio = 0.0001obtained abs = 8.57691e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00780209; expected ratio = 0.001obtained abs = 3.19847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944080e+05 Mflops = 367.47 -Solve time = 0.00 -Solve flops = 1.730800e+04 Mflops = 493.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0021398; expected ratio = 0.0001obtained abs = 8.58433e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00575668; expected ratio = 0.001obtained abs = 2.36147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4761 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.59419 - Final Residual ratio : 0.00134709 - Residual ratio : 0.000844999 - Slope : -0.0995525 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48651 - Final Residual ratio : 0.00137613 - Residual ratio : 0.00092575 - Slope : -0.0550048 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33601 - Final Residual ratio : 0.00132166 - Residual ratio : 0.000989258 - Slope : -0.049433 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17593 - Final Residual ratio : 0.00110073 - Residual ratio : 0.000936057 - Slope : -0.043512 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.20557 - Final Residual ratio : 0.000791342 - Residual ratio : 0.000656406 - Slope : -0.0446213 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.913628 - Final Residual ratio : 0.000871558 - Residual ratio : 0.000953953 - Slope : -0.035106 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.0267 - Final Residual ratio : 0.0178445 - Residual ratio : 0.000810128 - Slope : -0.786031 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.28849 - Final Residual ratio : 0.00433517 - Residual ratio : 0.000594797 - Slope : -0.242805 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.55432 - Final Residual ratio : 0.00342037 - Residual ratio : 0.000962313 - Slope : -0.221931 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.38553 - Final Residual ratio : 0.00235386 - Residual ratio : 0.000986724 - Slope : -0.0851134 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944080e+05 Mflops = 366.15 -Solve time = 0.00 -Solve flops = 1.730800e+04 Mflops = 493.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.176853; expected ratio = 0.0001obtained abs = 0.000861359; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.261998; expected ratio = 0.001obtained abs = 124.022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941760e+05 Mflops = 367.86 -Solve time = 0.00 -Solve flops = 1.729400e+04 Mflops = 493.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0182459; expected ratio = 0.0001obtained abs = 8.7577e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.385177; expected ratio = 0.001obtained abs = 159.328; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 368.11 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0103115; expected ratio = 0.0001obtained abs = 4.9795e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.182911; expected ratio = 0.001obtained abs = 75.5964; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 368.44 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00670038; expected ratio = 0.0001obtained abs = 3.23879e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.128465; expected ratio = 0.001obtained abs = 52.1396; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943120e+05 Mflops = 368.11 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00450478; expected ratio = 0.0001obtained abs = 2.17986e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.12243; expected ratio = 0.001obtained abs = 50.3519; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 367.77 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00421792; expected ratio = 0.0001obtained abs = 2.04556e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1151; expected ratio = 0.001obtained abs = 46.039; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 368.44 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00392851; expected ratio = 0.0001obtained abs = 1.90587e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0954208; expected ratio = 0.001obtained abs = 38.8559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 367.61 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00250231; expected ratio = 0.0001obtained abs = 1.21369e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0757422; expected ratio = 0.001obtained abs = 30.4844; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 368.44 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 507.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00219501; expected ratio = 0.0001obtained abs = 1.06571e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0660277; expected ratio = 0.001obtained abs = 26.7002; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 360.13 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 496.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00260498; expected ratio = 0.0001obtained abs = 1.26493e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.058784; expected ratio = 0.001obtained abs = 23.588; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.948040e+05 Mflops = 368.88 -Solve time = 0.00 -Solve flops = 1.733000e+04 Mflops = 511.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00181973; expected ratio = 0.0001obtained abs = 8.83363e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0529599; expected ratio = 0.001obtained abs = 21.4633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.942280e+05 Mflops = 368.45 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 496.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00196034; expected ratio = 0.0001obtained abs = 9.51894e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0445568; expected ratio = 0.001obtained abs = 17.8846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 368.94 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 496.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00184709; expected ratio = 0.0001obtained abs = 8.97125e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0367555; expected ratio = 0.001obtained abs = 14.832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.948040e+05 Mflops = 369.55 -Solve time = 0.00 -Solve flops = 1.733000e+04 Mflops = 494.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00160202; expected ratio = 0.0001obtained abs = 7.77826e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0291732; expected ratio = 0.001obtained abs = 11.742; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 366.94 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 510.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00195913; expected ratio = 0.0001obtained abs = 9.51416e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.026266; expected ratio = 0.001obtained abs = 10.6016; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 368.27 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 510.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00170951; expected ratio = 0.0001obtained abs = 8.30181e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234475; expected ratio = 0.001obtained abs = 9.42431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 359.49 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00160079; expected ratio = 0.0001obtained abs = 7.77357e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0202453; expected ratio = 0.001obtained abs = 8.17162; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 367.61 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00161599; expected ratio = 0.0001obtained abs = 7.84648e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162685; expected ratio = 0.001obtained abs = 6.54903; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 369.11 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00141424; expected ratio = 0.0001obtained abs = 6.86831e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0135789; expected ratio = 0.001obtained abs = 5.47182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.941320e+05 Mflops = 362.21 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00145398; expected ratio = 0.0001obtained abs = 7.06069e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112304; expected ratio = 0.001obtained abs = 4.52154; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.88992 - Final Residual ratio : 0.00155483 - Residual ratio : 0.000822698 - Slope : -0.0629454 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.62033 - Final Residual ratio : 0.00131928 - Residual ratio : 0.000814201 - Slope : -0.0539672 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33516 - Final Residual ratio : 0.00104826 - Residual ratio : 0.000785122 - Slope : -0.0444704 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06344 - Final Residual ratio : 0.000764392 - Residual ratio : 0.000718791 - Slope : -0.0354226 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08275 - Final Residual ratio : 0.00103137 - Residual ratio : 0.000952544 - Slope : -0.038633 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.758308 - Final Residual ratio : 0.000650945 - Residual ratio : 0.000858418 - Slope : -0.0270592 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.778856 - Final Residual ratio : 0.00058013 - Residual ratio : 0.00074485 - Slope : -0.0277956 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.824842 - Final Residual ratio : 0.000619334 - Residual ratio : 0.000750851 - Slope : -0.0284215 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.854119 - Final Residual ratio : 0.0008347 - Residual ratio : 0.000977264 - Slope : -0.0328186 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09564 - Final Residual ratio : 0.000931726 - Residual ratio : 0.000850393 - Slope : -0.0377486 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.4951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.4951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845850e+05 Mflops = 357.77 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 480.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.15609; expected ratio = 0.0001obtained abs = 0.00089759; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.330777; expected ratio = 0.001obtained abs = 160.737; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847070e+05 Mflops = 359.33 -Solve time = 0.00 -Solve flops = 1.685000e+04 Mflops = 420.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0205057; expected ratio = 0.0001obtained abs = 0.000116033; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.543313; expected ratio = 0.001obtained abs = 224.337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.848430e+05 Mflops = 358.93 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 494.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00673393; expected ratio = 0.0001obtained abs = 3.8274e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.274997; expected ratio = 0.001obtained abs = 114.198; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847290e+05 Mflops = 359.37 -Solve time = 0.00 -Solve flops = 1.685400e+04 Mflops = 480.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00572298; expected ratio = 0.0001obtained abs = 3.25486e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.206199; expected ratio = 0.001obtained abs = 83.2783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.848430e+05 Mflops = 359.60 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 497.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00282576; expected ratio = 0.0001obtained abs = 1.60752e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.198388; expected ratio = 0.001obtained abs = 82.2894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.848430e+05 Mflops = 351.45 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 481.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00259617; expected ratio = 0.0001obtained abs = 1.4787e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.191267; expected ratio = 0.001obtained abs = 76.7188; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847290e+05 Mflops = 358.05 -Solve time = 0.00 -Solve flops = 1.685400e+04 Mflops = 494.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00309436; expected ratio = 0.0001obtained abs = 1.76366e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172925; expected ratio = 0.001obtained abs = 70.9953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846630e+05 Mflops = 359.91 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 480.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00194073; expected ratio = 0.0001obtained abs = 1.10567e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.148644; expected ratio = 0.001obtained abs = 59.8726; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847290e+05 Mflops = 359.37 -Solve time = 0.00 -Solve flops = 1.685400e+04 Mflops = 497.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0019526; expected ratio = 0.0001obtained abs = 1.11307e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140043; expected ratio = 0.001obtained abs = 57.3317; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846630e+05 Mflops = 359.25 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 480.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00193397; expected ratio = 0.0001obtained abs = 1.1026e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120281; expected ratio = 0.001obtained abs = 48.3916; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847290e+05 Mflops = 359.37 -Solve time = 0.00 -Solve flops = 1.685400e+04 Mflops = 480.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0015846; expected ratio = 0.0001obtained abs = 9.03408e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110764; expected ratio = 0.001obtained abs = 45.2909; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846630e+05 Mflops = 358.58 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 480.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00162302; expected ratio = 0.0001obtained abs = 9.2522e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0882225; expected ratio = 0.001obtained abs = 35.6109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845850e+05 Mflops = 350.95 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 480.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00147263; expected ratio = 0.0001obtained abs = 8.39745e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0796786; expected ratio = 0.001obtained abs = 32.4687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845850e+05 Mflops = 359.09 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 497.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00140144; expected ratio = 0.0001obtained abs = 7.99033e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0629801; expected ratio = 0.001obtained abs = 25.4776; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.850330e+05 Mflops = 359.30 -Solve time = 0.00 -Solve flops = 1.687400e+04 Mflops = 494.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00134336; expected ratio = 0.0001obtained abs = 7.65945e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0563029; expected ratio = 0.001obtained abs = 22.9299; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.850330e+05 Mflops = 359.97 -Solve time = 0.00 -Solve flops = 1.687400e+04 Mflops = 481.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00141985; expected ratio = 0.0001obtained abs = 8.09562e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.044885; expected ratio = 0.001obtained abs = 18.1703; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845850e+05 Mflops = 358.43 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 493.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0018102; expected ratio = 0.0001obtained abs = 1.03234e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0390993; expected ratio = 0.001obtained abs = 15.9069; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846630e+05 Mflops = 358.58 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 497.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00183461; expected ratio = 0.0001obtained abs = 1.04589e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0305173; expected ratio = 0.001obtained abs = 12.3747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846630e+05 Mflops = 359.91 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 494.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00190941; expected ratio = 0.0001obtained abs = 1.08884e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0260721; expected ratio = 0.001obtained abs = 10.5984; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846630e+05 Mflops = 359.25 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 494.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00194404; expected ratio = 0.0001obtained abs = 1.10831e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211019; expected ratio = 0.001obtained abs = 8.56013; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.4961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.795745 - Final Residual ratio : 0.000760143 - Residual ratio : 0.00095526 - Slope : -0.0294439 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.753646 - Final Residual ratio : 0.000708979 - Residual ratio : 0.000940731 - Slope : -0.0301175 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.69681 - Final Residual ratio : 0.000694869 - Residual ratio : 0.000997214 - Slope : -0.025782 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.4991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.644136 - Final Residual ratio : 0.000589055 - Residual ratio : 0.000914488 - Slope : -0.0229838 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.4991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.925536 - Final Residual ratio : 0.000805071 - Residual ratio : 0.000869844 - Slope : -0.0330261 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.560385 - Final Residual ratio : 0.000539465 - Residual ratio : 0.000962669 - Slope : -0.0199945 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.545945 - Final Residual ratio : 0.000536509 - Residual ratio : 0.000982717 - Slope : -0.0194789 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.533482 - Final Residual ratio : 0.000443408 - Residual ratio : 0.000831158 - Slope : -0.0190371 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5041 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.527177 - Final Residual ratio : 0.000391973 - Residual ratio : 0.000743532 - Slope : -0.0219494 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.870767 - Final Residual ratio : 0.000761129 - Residual ratio : 0.000874091 - Slope : -0.0310716 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846630e+05 Mflops = 351.10 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 480.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.135338; expected ratio = 0.0001obtained abs = 0.000891944; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.406571; expected ratio = 0.001obtained abs = 207.684; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.848430e+05 Mflops = 360.93 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 497.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0144618; expected ratio = 0.0001obtained abs = 9.4148e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.786736; expected ratio = 0.001obtained abs = 325.752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859830e+05 Mflops = 361.81 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 495.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00586992; expected ratio = 0.0001obtained abs = 3.83575e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.418069; expected ratio = 0.001obtained abs = 172.731; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846630e+05 Mflops = 360.08 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 494.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0045; expected ratio = 0.0001obtained abs = 2.94319e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.326037; expected ratio = 0.001obtained abs = 130.202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845850e+05 Mflops = 359.76 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 497.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00269963; expected ratio = 0.0001obtained abs = 1.76693e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.319909; expected ratio = 0.001obtained abs = 131.436; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845850e+05 Mflops = 360.60 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 480.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00264168; expected ratio = 0.0001obtained abs = 1.73018e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.337917; expected ratio = 0.001obtained abs = 134.646; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845850e+05 Mflops = 360.43 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 483.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00277517; expected ratio = 0.0001obtained abs = 1.81884e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.324082; expected ratio = 0.001obtained abs = 131.966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 357.59 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 495.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00242849; expected ratio = 0.0001obtained abs = 1.59116e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.296581; expected ratio = 0.001obtained abs = 118.15; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845850e+05 Mflops = 360.43 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 493.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00248558; expected ratio = 0.0001obtained abs = 1.62947e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.278586; expected ratio = 0.001obtained abs = 112.981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000459194 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 357.75 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00246857; expected ratio = 0.0001obtained abs = 1.61804e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.231504; expected ratio = 0.001obtained abs = 91.9332; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 358.25 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 495.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0024707; expected ratio = 0.0001obtained abs = 1.61993e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.212933; expected ratio = 0.001obtained abs = 86.1419; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00249165; expected ratio = 0.0001obtained abs = 1.63316e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1727; expected ratio = 0.001obtained abs = 68.682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.002496; expected ratio = 0.0001obtained abs = 1.6367e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.160376; expected ratio = 0.001obtained abs = 64.7111; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 352.02 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 495.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00249976; expected ratio = 0.0001obtained abs = 1.63857e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140463; expected ratio = 0.001obtained abs = 55.9553; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0024949; expected ratio = 0.0001obtained abs = 1.63593e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.142414; expected ratio = 0.001obtained abs = 57.3973; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 357.59 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.002498; expected ratio = 0.0001obtained abs = 1.63746e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116474; expected ratio = 0.001obtained abs = 46.5484; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 349.45 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00249938; expected ratio = 0.0001obtained abs = 1.63892e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116033; expected ratio = 0.001obtained abs = 46.6859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00250099; expected ratio = 0.0001obtained abs = 1.6394e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0932499; expected ratio = 0.001obtained abs = 37.3773; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 479.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00249865; expected ratio = 0.0001obtained abs = 1.63844e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0880229; expected ratio = 0.001obtained abs = 35.3735; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.831290e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.679000e+04 Mflops = 492.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00249802; expected ratio = 0.0001obtained abs = 1.63748e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0725937; expected ratio = 0.001obtained abs = 29.1413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.5061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.517686 - Final Residual ratio : 0.000495022 - Residual ratio : 0.000956221 - Slope : -0.0184711 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.523876 - Final Residual ratio : 0.000480499 - Residual ratio : 0.0009172 - Slope : -0.0186927 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.521404 - Final Residual ratio : 0.000433563 - Residual ratio : 0.000831529 - Slope : -0.0186061 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.515582 - Final Residual ratio : 0.000436968 - Residual ratio : 0.000847523 - Slope : -0.0190794 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.855687 - Final Residual ratio : 0.000680293 - Residual ratio : 0.000795025 - Slope : -0.030536 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.492183 - Final Residual ratio : 0.000366793 - Residual ratio : 0.000745236 - Slope : -0.0196727 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.489832 - Final Residual ratio : 0.000336527 - Residual ratio : 0.000687025 - Slope : -0.0195798 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.482396 - Final Residual ratio : 0.000370097 - Residual ratio : 0.000767206 - Slope : -0.019281 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.2944 - Final Residual ratio : 0.024204 - Residual ratio : 0.000886775 - Slope : -1.09081 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0536 - Final Residual ratio : 0.00986205 - Residual ratio : 0.000818184 - Slope : -0.46322 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845850e+05 Mflops = 356.28 -Solve time = 0.00 -Solve flops = 1.684200e+04 Mflops = 480.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.120551; expected ratio = 0.0001obtained abs = 0.000898171; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.473085; expected ratio = 0.001obtained abs = 255.516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846290e+05 Mflops = 360.68 -Solve time = 0.00 -Solve flops = 1.684400e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0166315; expected ratio = 0.0001obtained abs = 0.000122257; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.00821; expected ratio = 0.001obtained abs = 435.673; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.846290e+05 Mflops = 360.01 -Solve time = 0.00 -Solve flops = 1.684400e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00530414; expected ratio = 0.0001obtained abs = 3.9098e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.568817; expected ratio = 0.001obtained abs = 237.327; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 359.44 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00416959; expected ratio = 0.0001obtained abs = 3.07235e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.364876; expected ratio = 0.001obtained abs = 147.779; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.95 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00285553; expected ratio = 0.0001obtained abs = 2.10547e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.373314; expected ratio = 0.001obtained abs = 156.924; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 352.74 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 480.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00255663; expected ratio = 0.0001obtained abs = 1.88534e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.451418; expected ratio = 0.001obtained abs = 185.826; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 359.44 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00255466; expected ratio = 0.0001obtained abs = 1.88488e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.4413; expected ratio = 0.001obtained abs = 183.419; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859050e+05 Mflops = 361.83 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 498.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00246314; expected ratio = 0.0001obtained abs = 1.81648e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.393794; expected ratio = 0.001obtained abs = 160.216; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.11 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 480.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.002522; expected ratio = 0.0001obtained abs = 1.86123e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.373688; expected ratio = 0.001obtained abs = 154.906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 359.44 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 497.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00246991; expected ratio = 0.0001obtained abs = 1.82169e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.358427; expected ratio = 0.001obtained abs = 145.786; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 353.86 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00253258; expected ratio = 0.0001obtained abs = 1.86902e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.342835; expected ratio = 0.001obtained abs = 141.894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.78 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 484.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00252545; expected ratio = 0.0001obtained abs = 1.86261e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.303898; expected ratio = 0.001obtained abs = 123.307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.11 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 497.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00258213; expected ratio = 0.0001obtained abs = 1.9057e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.282417; expected ratio = 0.001obtained abs = 116.531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.95 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00256788; expected ratio = 0.0001obtained abs = 1.89389e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.228193; expected ratio = 0.001obtained abs = 92.4327; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.28 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00259303; expected ratio = 0.0001obtained abs = 1.91373e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.209312; expected ratio = 0.001obtained abs = 86.1752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.95 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00259064; expected ratio = 0.0001obtained abs = 1.91069e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172569; expected ratio = 0.001obtained abs = 69.9357; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.95 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 480.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00260799; expected ratio = 0.0001obtained abs = 1.92479e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.162441; expected ratio = 0.001obtained abs = 66.77; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.95 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00261103; expected ratio = 0.0001obtained abs = 1.92572e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145599; expected ratio = 0.001obtained abs = 59.0891; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.847650e+05 Mflops = 360.28 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 497.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00261528; expected ratio = 0.0001obtained abs = 1.93016e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.148555; expected ratio = 0.001obtained abs = 60.9781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.844660e+05 Mflops = 360.87 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 482.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00261969; expected ratio = 0.0001obtained abs = 1.9321e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.126295; expected ratio = 0.001obtained abs = 51.3985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.5161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.01607 - Final Residual ratio : 0.00169373 - Residual ratio : 0.000840114 - Slope : -0.0746064 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.76114 - Final Residual ratio : 0.00220306 - Residual ratio : 0.000797882 - Slope : -0.0985334 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.02446 - Final Residual ratio : 0.00285565 - Residual ratio : 0.000944184 - Slope : -0.107914 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.78807 - Final Residual ratio : 0.00236434 - Residual ratio : 0.000848019 - Slope : -0.0960589 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.51892 - Final Residual ratio : 0.00228437 - Residual ratio : 0.000906884 - Slope : -0.0867805 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81794 - Final Residual ratio : 0.00136648 - Residual ratio : 0.000751662 - Slope : -0.0626404 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.3336 - Final Residual ratio : 0.00110671 - Residual ratio : 0.000829869 - Slope : -0.0475889 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03288 - Final Residual ratio : 0.000667161 - Residual ratio : 0.000645926 - Slope : -0.0430087 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.929359 - Final Residual ratio : 0.000891886 - Residual ratio : 0.000959678 - Slope : -0.0442127 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24155 - Final Residual ratio : 0.00118055 - Residual ratio : 0.000950862 - Slope : -0.0539293 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5251 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.845470e+05 Mflops = 356.87 -Solve time = 0.00 -Solve flops = 1.684000e+04 Mflops = 480.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.104463; expected ratio = 0.0001obtained abs = 0.000860013; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.526868; expected ratio = 0.001obtained abs = 295.576; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.859050e+05 Mflops = 361.66 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 481.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0122102; expected ratio = 0.0001obtained abs = 9.94876e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.21674; expected ratio = 0.001obtained abs = 592.201; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.858670e+05 Mflops = 360.08 -Solve time = 0.00 -Solve flops = 1.688800e+04 Mflops = 498.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0052858; expected ratio = 0.0001obtained abs = 4.32169e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.865895; expected ratio = 0.001obtained abs = 361.506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856870e+05 Mflops = 353.05 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 481.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00424022; expected ratio = 0.0001obtained abs = 3.46796e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.458419; expected ratio = 0.001obtained abs = 189.231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856870e+05 Mflops = 360.57 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 481.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00370421; expected ratio = 0.0001obtained abs = 3.03276e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.507692; expected ratio = 0.001obtained abs = 215.445; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856870e+05 Mflops = 361.24 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 484.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00331426; expected ratio = 0.0001obtained abs = 2.71457e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.571645; expected ratio = 0.001obtained abs = 238.412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856870e+05 Mflops = 361.24 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 495.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00357688; expected ratio = 0.0001obtained abs = 2.93222e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.563806; expected ratio = 0.001obtained abs = 237.258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856870e+05 Mflops = 359.90 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 498.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00326413; expected ratio = 0.0001obtained abs = 2.67445e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.536177; expected ratio = 0.001obtained abs = 221.471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856870e+05 Mflops = 361.24 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 481.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00349763; expected ratio = 0.0001obtained abs = 2.86817e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.523905; expected ratio = 0.001obtained abs = 219.204; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.856870e+05 Mflops = 360.57 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 481.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00380065; expected ratio = 0.0001obtained abs = 3.11549e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.51263; expected ratio = 0.001obtained abs = 209.5; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.862310e+05 Mflops = 355.37 -Solve time = 0.00 -Solve flops = 1.691000e+04 Mflops = 482.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0037748; expected ratio = 0.0001obtained abs = 3.09641e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.496435; expected ratio = 0.001obtained abs = 206.902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.862310e+05 Mflops = 361.62 -Solve time = 0.00 -Solve flops = 1.691000e+04 Mflops = 482.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00403852; expected ratio = 0.0001obtained abs = 3.31101e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.491934; expected ratio = 0.001obtained abs = 199.839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842310e+05 Mflops = 358.40 -Solve time = 0.00 -Solve flops = 1.682600e+04 Mflops = 483.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00434505; expected ratio = 0.0001obtained abs = 3.56512e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.475807; expected ratio = 0.001obtained abs = 197.215; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842310e+05 Mflops = 359.07 -Solve time = 0.00 -Solve flops = 1.682600e+04 Mflops = 497.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0046291; expected ratio = 0.0001obtained abs = 3.79597e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.473687; expected ratio = 0.001obtained abs = 191.348; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842310e+05 Mflops = 359.24 -Solve time = 0.00 -Solve flops = 1.682600e+04 Mflops = 480.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00468575; expected ratio = 0.0001obtained abs = 3.84526e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.457894; expected ratio = 0.001obtained abs = 189.089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842310e+05 Mflops = 359.24 -Solve time = 0.00 -Solve flops = 1.682600e+04 Mflops = 493.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0046609; expected ratio = 0.0001obtained abs = 3.82222e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.45822; expected ratio = 0.001obtained abs = 184.616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842310e+05 Mflops = 359.91 -Solve time = 0.00 -Solve flops = 1.682600e+04 Mflops = 480.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00453644; expected ratio = 0.0001obtained abs = 3.72235e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.44335; expected ratio = 0.001obtained abs = 182.927; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.842310e+05 Mflops = 353.65 -Solve time = 0.00 -Solve flops = 1.682600e+04 Mflops = 480.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00438713; expected ratio = 0.0001obtained abs = 3.59695e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.446992; expected ratio = 0.001obtained abs = 179.978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.854090e+05 Mflops = 361.37 -Solve time = 0.00 -Solve flops = 1.686400e+04 Mflops = 481.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0042104; expected ratio = 0.0001obtained abs = 3.45407e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.433064; expected ratio = 0.001obtained abs = 178.691; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.854090e+05 Mflops = 360.70 -Solve time = 0.00 -Solve flops = 1.686400e+04 Mflops = 481.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00363055; expected ratio = 0.0001obtained abs = 2.97598e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.44076; expected ratio = 0.001obtained abs = 177.486; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.5261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.939207 - Final Residual ratio : 0.000860171 - Residual ratio : 0.000915849 - Slope : -0.0347536 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.875682 - Final Residual ratio : 0.000637204 - Residual ratio : 0.000727666 - Slope : -0.0364602 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.791443 - Final Residual ratio : 0.000764683 - Residual ratio : 0.000966188 - Slope : -0.0465105 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.701948 - Final Residual ratio : 0.000566056 - Residual ratio : 0.000806407 - Slope : -0.0280553 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.960057 - Final Residual ratio : 0.000837669 - Residual ratio : 0.000872521 - Slope : -0.0383688 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.581165 - Final Residual ratio : 0.000552108 - Residual ratio : 0.000950002 - Slope : -0.0207362 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.529411 - Final Residual ratio : 0.000408845 - Residual ratio : 0.000772263 - Slope : -0.0182415 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.49971 - Final Residual ratio : 0.000356742 - Residual ratio : 0.000713897 - Slope : -0.0172191 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.483191 - Final Residual ratio : 0.000421025 - Residual ratio : 0.000871343 - Slope : -0.0185681 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.779629 - Final Residual ratio : 0.000552945 - Residual ratio : 0.000709241 - Slope : -0.0324615 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5351 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.857350e+05 Mflops = 353.78 -Solve time = 0.00 -Solve flops = 1.688000e+04 Mflops = 481.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.106077; expected ratio = 0.0001obtained abs = 0.000967814; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.648255; expected ratio = 0.001obtained abs = 371.607; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.872590e+05 Mflops = 352.68 -Solve time = 0.00 -Solve flops = 1.693400e+04 Mflops = 483.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0152235; expected ratio = 0.0001obtained abs = 0.000137501; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.33421; expected ratio = 0.001obtained abs = 1218.71; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.870030e+05 Mflops = 362.45 -Solve time = 0.00 -Solve flops = 1.692000e+04 Mflops = 482.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00698154; expected ratio = 0.0001obtained abs = 6.33212e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.31648; expected ratio = 0.001obtained abs = 945.48; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.872690e+05 Mflops = 362.30 -Solve time = 0.00 -Solve flops = 1.696600e+04 Mflops = 484.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00538928; expected ratio = 0.0001obtained abs = 4.89405e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.48403; expected ratio = 0.001obtained abs = 190.304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861070e+05 Mflops = 360.05 -Solve time = 0.00 -Solve flops = 1.690000e+04 Mflops = 482.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00505956; expected ratio = 0.0001obtained abs = 4.60249e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.424639; expected ratio = 0.001obtained abs = 167.245; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861070e+05 Mflops = 361.38 -Solve time = 0.00 -Solve flops = 1.690000e+04 Mflops = 482.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00503719; expected ratio = 0.0001obtained abs = 4.58456e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.347072; expected ratio = 0.001obtained abs = 133.898; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861070e+05 Mflops = 360.72 -Solve time = 0.00 -Solve flops = 1.690000e+04 Mflops = 482.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00615212; expected ratio = 0.0001obtained abs = 5.60707e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.367245; expected ratio = 0.001obtained abs = 142.483; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.861070e+05 Mflops = 361.38 -Solve time = 0.00 -Solve flops = 1.690000e+04 Mflops = 485.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00623429; expected ratio = 0.0001obtained abs = 5.68192e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.451133; expected ratio = 0.001obtained abs = 174.492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.877850e+05 Mflops = 363.80 -Solve time = 0.00 -Solve flops = 1.698200e+04 Mflops = 487.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00687929; expected ratio = 0.0001obtained abs = 6.2768e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.399378; expected ratio = 0.001obtained abs = 149.84; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.879650e+05 Mflops = 363.64 -Solve time = 0.00 -Solve flops = 1.699200e+04 Mflops = 498.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00597928; expected ratio = 0.0001obtained abs = 5.45376e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.282372; expected ratio = 0.001obtained abs = 105.479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.879650e+05 Mflops = 364.15 -Solve time = 0.00 -Solve flops = 1.699200e+04 Mflops = 501.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00568643; expected ratio = 0.0001obtained abs = 5.1907e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.258949; expected ratio = 0.001obtained abs = 95.9856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.879650e+05 Mflops = 363.48 -Solve time = 0.00 -Solve flops = 1.699200e+04 Mflops = 488.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00461397; expected ratio = 0.0001obtained abs = 4.20939e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.049133; expected ratio = 0.001obtained abs = 18.085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.878290e+05 Mflops = 364.73 -Solve time = 0.00 -Solve flops = 1.698400e+04 Mflops = 498.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0043594; expected ratio = 0.0001obtained abs = 3.97957e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0635703; expected ratio = 0.001obtained abs = 23.3953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.878290e+05 Mflops = 363.38 -Solve time = 0.00 -Solve flops = 1.698400e+04 Mflops = 498.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00374412; expected ratio = 0.0001obtained abs = 3.41577e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0481206; expected ratio = 0.001obtained abs = 17.695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.878290e+05 Mflops = 364.05 -Solve time = 0.00 -Solve flops = 1.698400e+04 Mflops = 498.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00365924; expected ratio = 0.0001obtained abs = 3.3402e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162796; expected ratio = 0.001obtained abs = 5.99363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.878290e+05 Mflops = 363.89 -Solve time = 0.00 -Solve flops = 1.698400e+04 Mflops = 487.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0034098; expected ratio = 0.0001obtained abs = 3.11057e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00631073; expected ratio = 0.001obtained abs = 2.32131; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.878290e+05 Mflops = 363.21 -Solve time = 0.00 -Solve flops = 1.698400e+04 Mflops = 484.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00333435; expected ratio = 0.0001obtained abs = 3.04339e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010029; expected ratio = 0.001obtained abs = 3.69556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.878290e+05 Mflops = 362.55 -Solve time = 0.00 -Solve flops = 1.698400e+04 Mflops = 498.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00319163; expected ratio = 0.0001obtained abs = 2.91144e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0168557; expected ratio = 0.001obtained abs = 6.20262; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.878290e+05 Mflops = 364.05 -Solve time = 0.00 -Solve flops = 1.698400e+04 Mflops = 484.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00313347; expected ratio = 0.0001obtained abs = 2.85992e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.019216; expected ratio = 0.001obtained abs = 7.08389; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.878290e+05 Mflops = 363.21 -Solve time = 0.00 -Solve flops = 1.698400e+04 Mflops = 487.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00304568; expected ratio = 0.0001obtained abs = 2.77828e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211851; expected ratio = 0.001obtained abs = 7.79758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.5361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.487073 - Final Residual ratio : 0.00038386 - Residual ratio : 0.000788095 - Slope : -0.0173818 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.491108 - Final Residual ratio : 0.000379748 - Residual ratio : 0.000773248 - Slope : -0.0169217 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5381 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.495319 - Final Residual ratio : 0.000384274 - Residual ratio : 0.00077581 - Slope : -0.0170667 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.495766 - Final Residual ratio : 0.000369904 - Residual ratio : 0.000746127 - Slope : -0.0170826 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.793524 - Final Residual ratio : 0.000768404 - Residual ratio : 0.000968343 - Slope : -0.0304906 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.487369 - Final Residual ratio : 0.000425187 - Residual ratio : 0.000872414 - Slope : -0.0173908 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.476063 - Final Residual ratio : 0.00040264 - Residual ratio : 0.00084577 - Slope : -0.017617 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.466174 - Final Residual ratio : 0.000446173 - Residual ratio : 0.000957095 - Slope : -0.0186291 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.458753 - Final Residual ratio : 0.000375949 - Residual ratio : 0.000819503 - Slope : -0.0183351 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.735856 - Final Residual ratio : 0.00056557 - Residual ratio : 0.000768587 - Slope : -0.0306371 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5451 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.970840e+05 Mflops = 371.19 -Solve time = 0.00 -Solve flops = 1.741800e+04 Mflops = 496.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.114147; expected ratio = 0.0001obtained abs = 0.0011634; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155155; expected ratio = 0.001obtained abs = 60.8669; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.985400e+05 Mflops = 375.28 -Solve time = 0.00 -Solve flops = 1.747000e+04 Mflops = 498.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0139946; expected ratio = 0.0001obtained abs = 0.000141103; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.217401; expected ratio = 0.001obtained abs = 85.53; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.975100e+05 Mflops = 372.66 -Solve time = 0.00 -Solve flops = 1.744200e+04 Mflops = 497.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00684819; expected ratio = 0.0001obtained abs = 6.90307e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137886; expected ratio = 0.001obtained abs = 54.8223; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.958780e+05 Mflops = 370.24 -Solve time = 0.00 -Solve flops = 1.737200e+04 Mflops = 495.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00589177; expected ratio = 0.0001obtained abs = 5.93043e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0300091; expected ratio = 0.001obtained abs = 12.0139; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000459194 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.958780e+05 Mflops = 370.24 -Solve time = 0.00 -Solve flops = 1.737200e+04 Mflops = 495.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00422616; expected ratio = 0.0001obtained abs = 4.25038e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0237443; expected ratio = 0.001obtained abs = 9.58965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.969820e+05 Mflops = 372.33 -Solve time = 0.00 -Solve flops = 1.741800e+04 Mflops = 496.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00334548; expected ratio = 0.0001obtained abs = 3.36119e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0132461; expected ratio = 0.001obtained abs = 5.37991; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.958780e+05 Mflops = 370.41 -Solve time = 0.00 -Solve flops = 1.737200e+04 Mflops = 495.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00262632; expected ratio = 0.0001obtained abs = 2.63706e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136291; expected ratio = 0.001obtained abs = 5.57347; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.953140e+05 Mflops = 369.18 -Solve time = 0.00 -Solve flops = 1.734600e+04 Mflops = 494.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0022912; expected ratio = 0.0001obtained abs = 2.29858e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.011471; expected ratio = 0.001obtained abs = 4.71207; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944340e+05 Mflops = 367.51 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00189204; expected ratio = 0.0001obtained abs = 1.89716e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0108928; expected ratio = 0.001obtained abs = 4.49907; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944340e+05 Mflops = 367.51 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 497.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0016949; expected ratio = 0.0001obtained abs = 1.69831e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00986941; expected ratio = 0.001obtained abs = 4.09056; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944340e+05 Mflops = 368.34 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 511.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00139381; expected ratio = 0.0001obtained abs = 1.39607e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00953337; expected ratio = 0.001obtained abs = 3.96837; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944340e+05 Mflops = 367.51 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 497.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00128545; expected ratio = 0.0001obtained abs = 1.28682e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00851238; expected ratio = 0.001obtained abs = 3.55291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.951820e+05 Mflops = 360.16 -Solve time = 0.00 -Solve flops = 1.734600e+04 Mflops = 494.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108332; expected ratio = 0.0001obtained abs = 1.08416e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00846248; expected ratio = 0.001obtained abs = 3.54437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946260e+05 Mflops = 367.22 -Solve time = 0.00 -Solve flops = 1.731400e+04 Mflops = 511.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00102276; expected ratio = 0.0001obtained abs = 1.02308e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00745435; expected ratio = 0.001obtained abs = 3.12889; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.947280e+05 Mflops = 368.07 -Solve time = 0.00 -Solve flops = 1.732000e+04 Mflops = 497.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000892769; expected ratio = 0.0001obtained abs = 8.9282e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00760618; expected ratio = 0.001obtained abs = 3.20185; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.937160e+05 Mflops = 366.32 -Solve time = 0.00 -Solve flops = 1.726200e+04 Mflops = 492.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000847423; expected ratio = 0.0001obtained abs = 8.47154e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00663683; expected ratio = 0.001obtained abs = 2.79851; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.937160e+05 Mflops = 366.98 -Solve time = 0.00 -Solve flops = 1.726200e+04 Mflops = 492.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000748733; expected ratio = 0.0001obtained abs = 7.48347e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00690101; expected ratio = 0.001obtained abs = 2.91675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.936720e+05 Mflops = 366.07 -Solve time = 0.00 -Solve flops = 1.726000e+04 Mflops = 509.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000713843; expected ratio = 0.0001obtained abs = 7.13259e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00605086; expected ratio = 0.001obtained abs = 2.56069; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.936720e+05 Mflops = 366.24 -Solve time = 0.00 -Solve flops = 1.726000e+04 Mflops = 492.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000642989; expected ratio = 0.0001obtained abs = 6.42368e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00636634; expected ratio = 0.001obtained abs = 2.69938; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.936720e+05 Mflops = 357.38 -Solve time = 0.00 -Solve flops = 1.726000e+04 Mflops = 492.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000621943; expected ratio = 0.0001obtained abs = 6.21188e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00566269; expected ratio = 0.001obtained abs = 2.40328; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.5461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.451911 - Final Residual ratio : 0.000383499 - Residual ratio : 0.000848617 - Slope : -0.0173664 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.453414 - Final Residual ratio : 0.000445058 - Residual ratio : 0.00098157 - Slope : -0.0174219 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.454144 - Final Residual ratio : 0.000396119 - Residual ratio : 0.000872233 - Slope : -0.0168055 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.455131 - Final Residual ratio : 0.00037809 - Residual ratio : 0.000830727 - Slope : -0.0162412 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.731218 - Final Residual ratio : 0.000712157 - Residual ratio : 0.000973933 - Slope : -0.0292202 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.455435 - Final Residual ratio : 0.000431504 - Residual ratio : 0.000947455 - Slope : -0.0162501 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.456296 - Final Residual ratio : 0.000396687 - Residual ratio : 0.000869363 - Slope : -0.0162821 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.453983 - Final Residual ratio : 0.000358956 - Residual ratio : 0.000790681 - Slope : -0.0162009 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.451192 - Final Residual ratio : 0.000447259 - Residual ratio : 0.000991282 - Slope : -0.0166942 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.719379 - Final Residual ratio : 0.000666817 - Residual ratio : 0.000926934 - Slope : -0.0299463 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5551 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943900e+05 Mflops = 367.43 -Solve time = 0.00 -Solve flops = 1.730000e+04 Mflops = 497.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.08787; expected ratio = 0.0001obtained abs = 0.000950863; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0793603; expected ratio = 0.001obtained abs = 33.2034; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.916080e+05 Mflops = 364.31 -Solve time = 0.00 -Solve flops = 1.717600e+04 Mflops = 503.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0217905; expected ratio = 0.0001obtained abs = 0.000235055; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0380261; expected ratio = 0.001obtained abs = 15.6721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944640e+05 Mflops = 368.24 -Solve time = 0.00 -Solve flops = 1.728800e+04 Mflops = 493.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00770018; expected ratio = 0.0001obtained abs = 8.31281e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0158007; expected ratio = 0.001obtained abs = 6.49214; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944640e+05 Mflops = 369.07 -Solve time = 0.00 -Solve flops = 1.728800e+04 Mflops = 493.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00266697; expected ratio = 0.0001obtained abs = 2.88067e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0154514; expected ratio = 0.001obtained abs = 6.31781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944640e+05 Mflops = 368.24 -Solve time = 0.00 -Solve flops = 1.728800e+04 Mflops = 493.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00161717; expected ratio = 0.0001obtained abs = 1.74738e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100205; expected ratio = 0.001obtained abs = 4.09099; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944640e+05 Mflops = 368.24 -Solve time = 0.00 -Solve flops = 1.728800e+04 Mflops = 507.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00126857; expected ratio = 0.0001obtained abs = 1.37097e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102493; expected ratio = 0.001obtained abs = 4.17911; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.944640e+05 Mflops = 368.24 -Solve time = 0.00 -Solve flops = 1.728800e+04 Mflops = 493.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000984978; expected ratio = 0.0001obtained abs = 1.06456e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00775548; expected ratio = 0.001obtained abs = 3.16424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 368.74 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 493.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000797097; expected ratio = 0.0001obtained abs = 8.61481e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00736744; expected ratio = 0.001obtained abs = 3.00738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 368.58 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 507.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000692262; expected ratio = 0.0001obtained abs = 7.48128e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00654865; expected ratio = 0.001obtained abs = 2.67746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 365.28 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 493.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000601196; expected ratio = 0.0001obtained abs = 6.49637e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00548833; expected ratio = 0.001obtained abs = 2.24675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 369.91 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 496.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000567622; expected ratio = 0.0001obtained abs = 6.13278e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00551032; expected ratio = 0.001obtained abs = 2.26018; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 368.58 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 493.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000512533; expected ratio = 0.0001obtained abs = 5.53673e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0041667; expected ratio = 0.001obtained abs = 1.7117; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 368.74 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 507.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00049507; expected ratio = 0.0001obtained abs = 5.34728e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00454653; expected ratio = 0.001obtained abs = 1.87143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 369.41 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 493.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000459123; expected ratio = 0.0001obtained abs = 4.95818e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00322238; expected ratio = 0.001obtained abs = 1.32852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 369.41 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 493.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000447063; expected ratio = 0.0001obtained abs = 4.82717e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00370608; expected ratio = 0.001obtained abs = 1.53079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 368.58 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 510.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00041562; expected ratio = 0.0001obtained abs = 4.48694e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0025263; expected ratio = 0.001obtained abs = 1.04508; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 363.81 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 493.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000460411; expected ratio = 0.0001obtained abs = 4.96976e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0165401; expected ratio = 0.001obtained abs = 6.86321; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 368.58 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 496.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000591413; expected ratio = 0.0001obtained abs = 6.38283e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0353821; expected ratio = 0.001obtained abs = 14.6594; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.946440e+05 Mflops = 369.41 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 493.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000499793; expected ratio = 0.0001obtained abs = 5.39339e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0229238; expected ratio = 0.001obtained abs = 9.52443; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943320e+05 Mflops = 369.49 -Solve time = 0.00 -Solve flops = 1.727200e+04 Mflops = 492.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000664203; expected ratio = 0.0001obtained abs = 7.16654e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0290909; expected ratio = 0.001obtained abs = 12.0899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.5561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.44568 - Final Residual ratio : 0.000410953 - Residual ratio : 0.000922083 - Slope : -0.0164914 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.446977 - Final Residual ratio : 0.000392795 - Residual ratio : 0.000878782 - Slope : -0.0165402 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.446124 - Final Residual ratio : 0.000411941 - Residual ratio : 0.000923378 - Slope : -0.0165078 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.445463 - Final Residual ratio : 0.000402635 - Residual ratio : 0.000903858 - Slope : -0.0164837 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.4675 - Final Residual ratio : 0.0232398 - Residual ratio : 0.000949825 - Slope : -0.940165 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.55918 - Final Residual ratio : 0.00584994 - Residual ratio : 0.000773885 - Slope : -0.269762 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.50037 - Final Residual ratio : 0.00293973 - Residual ratio : 0.000839835 - Slope : -0.129534 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.36569 - Final Residual ratio : 0.00198641 - Residual ratio : 0.000839675 - Slope : -0.0815069 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.9782 - Final Residual ratio : 0.00125709 - Residual ratio : 0.000635475 - Slope : -0.0658979 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83417 - Final Residual ratio : 0.00175064 - Residual ratio : 0.000954458 - Slope : -0.0631868 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5651 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.943320e+05 Mflops = 366.00 -Solve time = 0.00 -Solve flops = 1.727200e+04 Mflops = 492.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0780462; expected ratio = 0.0001obtained abs = 0.000909553; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0359008; expected ratio = 0.001obtained abs = 15.1543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.918920e+05 Mflops = 362.87 -Solve time = 0.00 -Solve flops = 1.719800e+04 Mflops = 504.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0110297; expected ratio = 0.0001obtained abs = 0.000127639; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0148034; expected ratio = 0.001obtained abs = 6.25515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.73 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00280686; expected ratio = 0.0001obtained abs = 3.25013e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00847883; expected ratio = 0.001obtained abs = 3.58126; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 361.92 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00183459; expected ratio = 0.0001obtained abs = 2.12438e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00581312; expected ratio = 0.001obtained abs = 2.45435; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.73 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00124015; expected ratio = 0.0001obtained abs = 1.43593e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00356853; expected ratio = 0.001obtained abs = 1.50745; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.57 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000930848; expected ratio = 0.0001obtained abs = 1.07776e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00310532; expected ratio = 0.001obtained abs = 1.31281; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.57 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 493.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000768063; expected ratio = 0.0001obtained abs = 8.89176e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00258273; expected ratio = 0.001obtained abs = 1.0935; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 364.05 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000660344; expected ratio = 0.0001obtained abs = 7.64364e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00264296; expected ratio = 0.001obtained abs = 1.12079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 363.23 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 507.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000609386; expected ratio = 0.0001obtained abs = 7.05252e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00284868; expected ratio = 0.001obtained abs = 1.21048; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.57 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 507.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000612319; expected ratio = 0.0001obtained abs = 7.08511e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170147; expected ratio = 0.001obtained abs = 7.25539; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.57 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00068684; expected ratio = 0.0001obtained abs = 7.94565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0375201; expected ratio = 0.001obtained abs = 15.9855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 364.05 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000556266; expected ratio = 0.0001obtained abs = 6.43387e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.012087; expected ratio = 0.001obtained abs = 5.16346; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.73 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00056637; expected ratio = 0.0001obtained abs = 6.5494e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00806506; expected ratio = 0.001obtained abs = 3.45342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.57 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000502845; expected ratio = 0.0001obtained abs = 5.81362e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00903496; expected ratio = 0.001obtained abs = 3.87474; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.73 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000498503; expected ratio = 0.0001obtained abs = 5.76238e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00986644; expected ratio = 0.001obtained abs = 4.24101; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.57 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 493.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000427779; expected ratio = 0.0001obtained abs = 4.94395e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00821432; expected ratio = 0.001obtained abs = 3.53558; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 363.23 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000431832; expected ratio = 0.0001obtained abs = 4.98998e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00877474; expected ratio = 0.001obtained abs = 3.78457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.57 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 503.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000372583; expected ratio = 0.0001obtained abs = 4.30462e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00682772; expected ratio = 0.001obtained abs = 2.94834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 356.61 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000372735; expected ratio = 0.0001obtained abs = 4.30575e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00741587; expected ratio = 0.001obtained abs = 3.20816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 362.73 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000326705; expected ratio = 0.0001obtained abs = 3.77346e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00558808; expected ratio = 0.001obtained abs = 2.42004; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.5661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35796 - Final Residual ratio : 0.000914413 - Residual ratio : 0.000673374 - Slope : -0.0452348 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0915 - Final Residual ratio : 0.000644937 - Residual ratio : 0.00059087 - Slope : -0.0363619 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.914927 - Final Residual ratio : 0.000649772 - Residual ratio : 0.00071019 - Slope : -0.0315268 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.830069 - Final Residual ratio : 0.00065512 - Residual ratio : 0.000789236 - Slope : -0.0331765 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12444 - Final Residual ratio : 0.000937074 - Residual ratio : 0.00083337 - Slope : -0.0432116 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.802171 - Final Residual ratio : 0.00078721 - Residual ratio : 0.000981349 - Slope : -0.0296809 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.773134 - Final Residual ratio : 0.000692253 - Residual ratio : 0.000895386 - Slope : -0.0275872 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.735102 - Final Residual ratio : 0.000622241 - Residual ratio : 0.00084647 - Slope : -0.0282492 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.68988 - Final Residual ratio : 0.000552456 - Residual ratio : 0.000800799 - Slope : -0.0265126 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.964859 - Final Residual ratio : 0.000931927 - Residual ratio : 0.000965869 - Slope : -0.034426 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5751 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 359.33 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 489.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0682701; expected ratio = 0.0001obtained abs = 0.000841488; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0446848; expected ratio = 0.001obtained abs = 19.1377; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.914720e+05 Mflops = 361.26 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 493.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0123947; expected ratio = 0.0001obtained abs = 0.00015218; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0228658; expected ratio = 0.001obtained abs = 9.67999; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.916080e+05 Mflops = 362.17 -Solve time = 0.00 -Solve flops = 1.717600e+04 Mflops = 490.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00389056; expected ratio = 0.0001obtained abs = 4.78364e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0138993; expected ratio = 0.001obtained abs = 5.84792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.916080e+05 Mflops = 361.52 -Solve time = 0.00 -Solve flops = 1.717600e+04 Mflops = 490.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0016376; expected ratio = 0.0001obtained abs = 2.01474e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0145088; expected ratio = 0.001obtained abs = 6.077; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 365.92 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 505.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00120313; expected ratio = 0.0001obtained abs = 1.48084e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0341043; expected ratio = 0.001obtained abs = 14.2037; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 366.08 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000891658; expected ratio = 0.0001obtained abs = 1.0978e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142344; expected ratio = 0.001obtained abs = 5.91865; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 366.08 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000671296; expected ratio = 0.0001obtained abs = 8.26646e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105935; expected ratio = 0.001obtained abs = 4.40108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 365.92 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 495.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000475987; expected ratio = 0.0001obtained abs = 5.86205e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0117265; expected ratio = 0.001obtained abs = 4.86686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 357.21 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000415325; expected ratio = 0.0001obtained abs = 5.11535e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0108353; expected ratio = 0.001obtained abs = 4.49843; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 365.26 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000302907; expected ratio = 0.0001obtained abs = 3.73084e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00931519; expected ratio = 0.001obtained abs = 3.86644; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 364.60 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000310106; expected ratio = 0.0001obtained abs = 3.81953e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187164; expected ratio = 0.001obtained abs = 7.78351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 366.75 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000286312; expected ratio = 0.0001obtained abs = 3.52636e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.024484; expected ratio = 0.001obtained abs = 10.1674; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 366.75 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000241653; expected ratio = 0.0001obtained abs = 2.97623e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0104427; expected ratio = 0.001obtained abs = 4.34282; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 366.75 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000189321; expected ratio = 0.0001obtained abs = 2.33159e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.001851; expected ratio = 0.001obtained abs = 0.770265; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 365.26 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000252464; expected ratio = 0.0001obtained abs = 3.10906e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0194112; expected ratio = 0.001obtained abs = 8.09646; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 357.21 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000382168; expected ratio = 0.0001obtained abs = 4.70605e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0389172; expected ratio = 0.001obtained abs = 16.202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 366.75 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000340118; expected ratio = 0.0001obtained abs = 4.18803e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0295855; expected ratio = 0.001obtained abs = 12.3459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932400e+05 Mflops = 365.42 -Solve time = 0.00 -Solve flops = 1.724600e+04 Mflops = 492.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000371936; expected ratio = 0.0001obtained abs = 4.57951e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234411; expected ratio = 0.001obtained abs = 9.78418; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.932560e+05 Mflops = 365.45 -Solve time = 0.00 -Solve flops = 1.725400e+04 Mflops = 492.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000261386; expected ratio = 0.0001obtained abs = 3.21812e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102649; expected ratio = 0.001obtained abs = 4.2868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.916080e+05 Mflops = 362.17 -Solve time = 0.00 -Solve flops = 1.717600e+04 Mflops = 490.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000217834; expected ratio = 0.0001obtained abs = 2.68178e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.007371; expected ratio = 0.001obtained abs = 3.08191; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.5761 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.609313 - Final Residual ratio : 0.000553917 - Residual ratio : 0.000909085 - Slope : -0.0209917 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.569836 - Final Residual ratio : 0.000542201 - Residual ratio : 0.000951504 - Slope : -0.0196308 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.538933 - Final Residual ratio : 0.000510386 - Residual ratio : 0.00094703 - Slope : -0.0185663 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.517419 - Final Residual ratio : 0.000458988 - Residual ratio : 0.000887074 - Slope : -0.0178262 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.834958 - Final Residual ratio : 0.000723305 - Residual ratio : 0.000866277 - Slope : -0.0297941 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.50595 - Final Residual ratio : 0.000448758 - Residual ratio : 0.000886962 - Slope : -0.0187223 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.5033 - Final Residual ratio : 0.00037552 - Residual ratio : 0.000746117 - Slope : -0.020117 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.500224 - Final Residual ratio : 0.000355121 - Residual ratio : 0.000709924 - Slope : -0.0199948 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5841 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.495941 - Final Residual ratio : 0.000357852 - Residual ratio : 0.000721562 - Slope : -0.0198233 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.816583 - Final Residual ratio : 0.000650896 - Residual ratio : 0.000797097 - Slope : -0.0326373 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5851 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.965120e+05 Mflops = 371.61 -Solve time = 0.00 -Solve flops = 1.734600e+04 Mflops = 481.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0664155; expected ratio = 0.0001obtained abs = 0.000873698; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0326864; expected ratio = 0.001obtained abs = 14.0073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.976260e+05 Mflops = 375.07 -Solve time = 0.00 -Solve flops = 1.741200e+04 Mflops = 496.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.010186; expected ratio = 0.0001obtained abs = 0.000133109; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.012557; expected ratio = 0.001obtained abs = 5.39088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.968260e+05 Mflops = 374.23 -Solve time = 0.00 -Solve flops = 1.737200e+04 Mflops = 495.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00178972; expected ratio = 0.0001obtained abs = 2.3402e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0160828; expected ratio = 0.001obtained abs = 6.90242; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.965200e+05 Mflops = 373.65 -Solve time = 0.00 -Solve flops = 1.735400e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000932799; expected ratio = 0.0001obtained abs = 1.2198e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0270796; expected ratio = 0.001obtained abs = 11.5845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.965200e+05 Mflops = 364.56 -Solve time = 0.00 -Solve flops = 1.735400e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000588183; expected ratio = 0.0001obtained abs = 7.69212e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0108573; expected ratio = 0.001obtained abs = 4.64278; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.965200e+05 Mflops = 373.65 -Solve time = 0.00 -Solve flops = 1.735400e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000441648; expected ratio = 0.0001obtained abs = 5.77625e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00469745; expected ratio = 0.001obtained abs = 2.00758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.965200e+05 Mflops = 372.97 -Solve time = 0.00 -Solve flops = 1.735400e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000301879; expected ratio = 0.0001obtained abs = 3.94837e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0052916; expected ratio = 0.001obtained abs = 2.26059; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.981600e+05 Mflops = 375.91 -Solve time = 0.00 -Solve flops = 1.743600e+04 Mflops = 497.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00028192; expected ratio = 0.0001obtained abs = 3.68747e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118003; expected ratio = 0.001obtained abs = 5.04516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 376.00 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000234344; expected ratio = 0.0001obtained abs = 3.0652e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0184286; expected ratio = 0.001obtained abs = 7.86889; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 374.64 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000211004; expected ratio = 0.0001obtained abs = 2.75995e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00747306; expected ratio = 0.001obtained abs = 3.19301; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 375.32 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000184645; expected ratio = 0.0001obtained abs = 2.41515e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00943868; expected ratio = 0.001obtained abs = 4.03635; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 374.64 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000185298; expected ratio = 0.0001obtained abs = 2.42364e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0164235; expected ratio = 0.001obtained abs = 7.01821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 376.00 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 499.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000170665; expected ratio = 0.0001obtained abs = 2.23222e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00657884; expected ratio = 0.001obtained abs = 2.81324; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 375.32 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000159264; expected ratio = 0.0001obtained abs = 2.08306e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00891745; expected ratio = 0.001obtained abs = 3.81714; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 375.32 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00016109; expected ratio = 0.0001obtained abs = 2.10688e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142316; expected ratio = 0.001obtained abs = 6.08864; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 376.00 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 483.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000155531; expected ratio = 0.0001obtained abs = 2.03413e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00571677; expected ratio = 0.001obtained abs = 2.44762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 376.00 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000133234; expected ratio = 0.0001obtained abs = 1.74247e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00754077; expected ratio = 0.001obtained abs = 3.23146; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 375.15 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 499.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000141952; expected ratio = 0.0001obtained abs = 1.85642e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0123142; expected ratio = 0.001obtained abs = 5.27528; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 374.64 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000198211; expected ratio = 0.0001obtained abs = 2.5921e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0220505; expected ratio = 0.001obtained abs = 9.46291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.974000e+05 Mflops = 375.32 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000332025; expected ratio = 0.0001obtained abs = 4.34189e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.042053; expected ratio = 0.001obtained abs = 18.0164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.5861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.484834 - Final Residual ratio : 0.000414402 - Residual ratio : 0.00085473 - Slope : -0.0179415 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.47718 - Final Residual ratio : 0.000418522 - Residual ratio : 0.000877073 - Slope : -0.0170272 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.467708 - Final Residual ratio : 0.000338027 - Residual ratio : 0.00072273 - Slope : -0.0161162 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.459211 - Final Residual ratio : 0.000355706 - Residual ratio : 0.000774604 - Slope : -0.0158226 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.780255 - Final Residual ratio : 0.000618249 - Residual ratio : 0.000792368 - Slope : -0.0278442 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.451935 - Final Residual ratio : 0.000328765 - Residual ratio : 0.00072746 - Slope : -0.0155726 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.451805 - Final Residual ratio : 0.000434449 - Residual ratio : 0.000961585 - Slope : -0.0161204 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.449836 - Final Residual ratio : 0.000364222 - Residual ratio : 0.000809679 - Slope : -0.0160525 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.448308 - Final Residual ratio : 0.000398958 - Residual ratio : 0.000889919 - Slope : -0.0165892 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.775057 - Final Residual ratio : 0.000627717 - Residual ratio : 0.000809897 - Slope : -0.0297857 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.5951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.5951 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.967840e+05 Mflops = 365.86 -Solve time = 0.00 -Solve flops = 1.736800e+04 Mflops = 495.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0614314; expected ratio = 0.0001obtained abs = 0.000852864; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0394881; expected ratio = 0.001obtained abs = 16.8748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.969780e+05 Mflops = 374.35 -Solve time = 0.00 -Solve flops = 1.737800e+04 Mflops = 499.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00833487; expected ratio = 0.0001obtained abs = 0.000115183; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0117828; expected ratio = 0.001obtained abs = 5.0136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.989080e+05 Mflops = 377.50 -Solve time = 0.00 -Solve flops = 1.747200e+04 Mflops = 498.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00188479; expected ratio = 0.0001obtained abs = 2.60693e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00976075; expected ratio = 0.001obtained abs = 4.14174; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.989080e+05 Mflops = 371.12 -Solve time = 0.00 -Solve flops = 1.747200e+04 Mflops = 498.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000747516; expected ratio = 0.0001obtained abs = 1.03415e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122698; expected ratio = 0.001obtained abs = 5.19909; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 377.74 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 499.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00049542; expected ratio = 0.0001obtained abs = 6.85479e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0201439; expected ratio = 0.001obtained abs = 8.51295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 377.74 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 499.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000377219; expected ratio = 0.0001obtained abs = 5.21997e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00971016; expected ratio = 0.001obtained abs = 4.10163; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 378.60 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 499.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000280931; expected ratio = 0.0001obtained abs = 3.88781e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00735892; expected ratio = 0.001obtained abs = 3.10767; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 378.42 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 486.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000197475; expected ratio = 0.0001obtained abs = 2.733e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112852; expected ratio = 0.001obtained abs = 4.76024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 378.60 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 499.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000220165; expected ratio = 0.0001obtained abs = 3.04716e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0209089; expected ratio = 0.001obtained abs = 8.82768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 378.60 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 486.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000304326; expected ratio = 0.0001obtained abs = 4.21207e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0416339; expected ratio = 0.001obtained abs = 17.5404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 377.74 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 486.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000295243; expected ratio = 0.0001obtained abs = 4.08648e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0307905; expected ratio = 0.001obtained abs = 12.986; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 378.60 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 486.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000215834; expected ratio = 0.0001obtained abs = 2.98742e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0108003; expected ratio = 0.001obtained abs = 4.55339; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 378.60 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 499.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000202575; expected ratio = 0.0001obtained abs = 2.80391e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0237399; expected ratio = 0.001obtained abs = 10.019; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 378.42 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 502.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000245462; expected ratio = 0.0001obtained abs = 3.39757e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0128591; expected ratio = 0.001obtained abs = 5.42533; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 379.11 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 499.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000288208; expected ratio = 0.0001obtained abs = 3.9892e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0385738; expected ratio = 0.001obtained abs = 16.2474; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 377.74 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 499.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000260888; expected ratio = 0.0001obtained abs = 3.61111e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0293643; expected ratio = 0.001obtained abs = 12.3845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 378.60 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 486.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000148767; expected ratio = 0.0001obtained abs = 2.05917e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00802244; expected ratio = 0.001obtained abs = 3.38286; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.002440e+05 Mflops = 379.18 -Solve time = 0.00 -Solve flops = 1.754200e+04 Mflops = 500.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000231086; expected ratio = 0.0001obtained abs = 3.19858e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.053026; expected ratio = 0.001obtained abs = 22.4398; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 377.74 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 486.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000299239; expected ratio = 0.0001obtained abs = 4.14187e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10188; expected ratio = 0.001obtained abs = 42.9416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.994840e+05 Mflops = 377.91 -Solve time = 0.00 -Solve flops = 1.750400e+04 Mflops = 486.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000258095; expected ratio = 0.0001obtained abs = 3.57238e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0579225; expected ratio = 0.001obtained abs = 24.4422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.5961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.449749 - Final Residual ratio : 0.000365334 - Residual ratio : 0.000812307 - Slope : -0.0166438 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.4502 - Final Residual ratio : 0.000396703 - Residual ratio : 0.000881173 - Slope : -0.0166594 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.447001 - Final Residual ratio : 0.000421459 - Residual ratio : 0.00094286 - Slope : -0.01654 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.5991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.443225 - Final Residual ratio : 0.000341011 - Residual ratio : 0.000769386 - Slope : -0.0158173 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.5991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.763836 - Final Residual ratio : 0.000735846 - Residual ratio : 0.000963356 - Slope : -0.02935 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6011 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.44014 - Final Residual ratio : 0.000371689 - Residual ratio : 0.00084448 - Slope : -0.015706 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.440217 - Final Residual ratio : 0.000376145 - Residual ratio : 0.000854453 - Slope : -0.0157086 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.437701 - Final Residual ratio : 0.000371794 - Residual ratio : 0.000849425 - Slope : -0.0156189 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.43547 - Final Residual ratio : 0.000350103 - Residual ratio : 0.000803966 - Slope : -0.01554 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.75459 - Final Residual ratio : 0.000709777 - Residual ratio : 0.000940613 - Slope : -0.0289954 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6051 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.978660e+05 Mflops = 369.18 -Solve time = 0.00 -Solve flops = 1.742600e+04 Mflops = 484.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0580872; expected ratio = 0.0001obtained abs = 0.000851963; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0257835; expected ratio = 0.001obtained abs = 11.0859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.008700e+05 Mflops = 380.37 -Solve time = 0.00 -Solve flops = 1.757800e+04 Mflops = 501.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00690951; expected ratio = 0.0001obtained abs = 0.000100772; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0268959; expected ratio = 0.001obtained abs = 11.5994; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 378.75 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 500.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00121874; expected ratio = 0.0001obtained abs = 1.77822e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0524958; expected ratio = 0.001obtained abs = 22.5782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 378.75 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 500.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000503414; expected ratio = 0.0001obtained abs = 7.3457e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0188701; expected ratio = 0.001obtained abs = 8.09997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 378.75 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 487.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000308921; expected ratio = 0.0001obtained abs = 4.50804e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00442484; expected ratio = 0.001obtained abs = 1.89758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 379.44 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 504.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000329938; expected ratio = 0.0001obtained abs = 4.81522e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0646573; expected ratio = 0.001obtained abs = 27.8147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.011400e+05 Mflops = 381.05 -Solve time = 0.00 -Solve flops = 1.758800e+04 Mflops = 501.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000368689; expected ratio = 0.0001obtained abs = 5.38114e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170151; expected ratio = 0.001obtained abs = 73.0415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 374.53 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 487.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00026435; expected ratio = 0.0001obtained abs = 3.85851e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107737; expected ratio = 0.001obtained abs = 46.0663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 379.44 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 500.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000206589; expected ratio = 0.0001obtained abs = 3.01559e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00871912; expected ratio = 0.001obtained abs = 3.72835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 379.61 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 500.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000245663; expected ratio = 0.0001obtained abs = 3.58609e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0500849; expected ratio = 0.001obtained abs = 21.4721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 379.44 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 500.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000269246; expected ratio = 0.0001obtained abs = 3.93047e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107175; expected ratio = 0.001obtained abs = 45.7888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 379.44 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 487.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000159098; expected ratio = 0.0001obtained abs = 2.32256e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.053644; expected ratio = 0.001obtained abs = 22.9074; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 380.30 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 500.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000115337; expected ratio = 0.0001obtained abs = 1.68376e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00759829; expected ratio = 0.001obtained abs = 3.24591; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 379.44 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 500.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000207988; expected ratio = 0.0001obtained abs = 3.03636e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0548272; expected ratio = 0.001obtained abs = 23.5014; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 379.44 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 500.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00015782; expected ratio = 0.0001obtained abs = 2.30401e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.151542; expected ratio = 0.001obtained abs = 64.9956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.003800e+05 Mflops = 379.61 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 487.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.44473e-05; expected ratio = 0.0001obtained abs = 1.37884e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.124165; expected ratio = 0.001obtained abs = 53.1194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.436245 - Final Residual ratio : 0.000436015 - Residual ratio : 0.000999472 - Slope : -0.0161411 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.437557 - Final Residual ratio : 0.000426001 - Residual ratio : 0.000973589 - Slope : -0.01619 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.435617 - Final Residual ratio : 0.000418033 - Residual ratio : 0.000959636 - Slope : -0.0161185 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.433309 - Final Residual ratio : 0.000402886 - Residual ratio : 0.000929789 - Slope : -0.0160336 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.748079 - Final Residual ratio : 0.000648393 - Residual ratio : 0.000866744 - Slope : -0.0287473 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.432943 - Final Residual ratio : 0.000345324 - Residual ratio : 0.000797621 - Slope : -0.0154499 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.433618 - Final Residual ratio : 0.000343277 - Residual ratio : 0.000791657 - Slope : -0.0154741 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.431514 - Final Residual ratio : 0.000428938 - Residual ratio : 0.000994029 - Slope : -0.0159661 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.429417 - Final Residual ratio : 0.000406037 - Residual ratio : 0.000945552 - Slope : -0.0158893 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.740606 - Final Residual ratio : 0.000664557 - Residual ratio : 0.000897316 - Slope : -0.0284593 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 16 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 125 - - Mesh vertices: 114 - Mesh triangles: 125 - Mesh edges: 205 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6151 -matrix_partition : [5](0,49,98,147,199) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 1.999640e+05 Mflops = 379.34 -Solve time = 0.00 -Solve flops = 1.753400e+04 Mflops = 503.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0544588; expected ratio = 0.0001obtained abs = 0.000838557; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131109; expected ratio = 0.001obtained abs = 57.5862; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 382.92 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00561011; expected ratio = 0.0001obtained abs = 8.59696e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.353335; expected ratio = 0.001obtained abs = 155.331; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.022320e+05 Mflops = 384.51 -Solve time = 0.00 -Solve flops = 1.761200e+04 Mflops = 502.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000846827; expected ratio = 0.0001obtained abs = 1.29828e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.227907; expected ratio = 0.001obtained abs = 98.277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.022320e+05 Mflops = 378.00 -Solve time = 0.00 -Solve flops = 1.761200e+04 Mflops = 502.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000424641; expected ratio = 0.0001obtained abs = 6.51056e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0324031; expected ratio = 0.001obtained abs = 13.9477; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010800e+05 Mflops = 383.71 -Solve time = 0.00 -Solve flops = 1.758000e+04 Mflops = 488.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000445284; expected ratio = 0.0001obtained abs = 6.82745e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0847054; expected ratio = 0.001obtained abs = 36.6226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 381.36 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000443618; expected ratio = 0.0001obtained abs = 6.80223e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.266004; expected ratio = 0.001obtained abs = 116.293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.021820e+05 Mflops = 383.72 -Solve time = 0.00 -Solve flops = 1.761800e+04 Mflops = 502.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000526085; expected ratio = 0.0001obtained abs = 8.06718e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.248644; expected ratio = 0.001obtained abs = 107.171; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 382.05 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 505.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000517491; expected ratio = 0.0001obtained abs = 7.93552e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0673233; expected ratio = 0.001obtained abs = 28.9064; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 377.77 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 505.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000521762; expected ratio = 0.0001obtained abs = 8.0015e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0327022; expected ratio = 0.001obtained abs = 14.0575; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 383.61 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000387846; expected ratio = 0.0001obtained abs = 5.94784e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0143276; expected ratio = 0.001obtained abs = 6.15287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 383.79 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 505.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000247166; expected ratio = 0.0001obtained abs = 3.79057e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0491337; expected ratio = 0.001obtained abs = 21.166; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 376.59 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000216824; expected ratio = 0.0001obtained abs = 3.32523e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.064289; expected ratio = 0.001obtained abs = 27.5979; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 382.92 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000191688; expected ratio = 0.0001obtained abs = 2.93978e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0833978; expected ratio = 0.001obtained abs = 35.9979; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 382.92 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000218498; expected ratio = 0.0001obtained abs = 3.35092e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105696; expected ratio = 0.001obtained abs = 45.3823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 382.22 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000227369; expected ratio = 0.0001obtained abs = 3.48698e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0476416; expected ratio = 0.001obtained abs = 20.4763; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 378.62 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000238967; expected ratio = 0.0001obtained abs = 3.66484e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0422371; expected ratio = 0.001obtained abs = 18.1734; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 383.61 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 488.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000204878; expected ratio = 0.0001obtained abs = 3.14205e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0562051; expected ratio = 0.001obtained abs = 24.1702; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 382.92 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000202086; expected ratio = 0.0001obtained abs = 3.09922e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0796989; expected ratio = 0.001obtained abs = 34.3098; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 374.41 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00019216; expected ratio = 0.0001obtained abs = 2.947e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0968701; expected ratio = 0.001obtained abs = 41.7025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 199 -RHS size in solver: 199 -Factor time = 0.00 -Factor flops = 2.010300e+05 Mflops = 383.79 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 488.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000188766; expected ratio = 0.0001obtained abs = 2.89493e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.179407; expected ratio = 0.001obtained abs = 77.4406; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.430162 - Final Residual ratio : 0.000339218 - Residual ratio : 0.000788582 - Slope : -0.0153508 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.6171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.431167 - Final Residual ratio : 0.000330615 - Residual ratio : 0.000766791 - Slope : -0.015387 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.42933 - Final Residual ratio : 0.00040513 - Residual ratio : 0.000943634 - Slope : -0.0158861 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.42731 - Final Residual ratio : 0.000389294 - Residual ratio : 0.000911032 - Slope : -0.0158119 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.735312 - Final Residual ratio : 0.000637718 - Residual ratio : 0.000867274 - Slope : -0.0282567 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.427962 - Final Residual ratio : 0.000324349 - Residual ratio : 0.000757893 - Slope : -0.0152728 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.428685 - Final Residual ratio : 0.000423275 - Residual ratio : 0.00098738 - Slope : -0.0158616 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.426852 - Final Residual ratio : 0.000411152 - Residual ratio : 0.00096322 - Slope : -0.0157941 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.424928 - Final Residual ratio : 0.000402271 - Residual ratio : 0.000946682 - Slope : -0.0157232 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.729543 - Final Residual ratio : 0.000659018 - Residual ratio : 0.000903329 - Slope : -0.028034 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 124 - - Mesh vertices: 114 - Mesh triangles: 124 - Mesh edges: 203 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6251 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.972380e+05 Mflops = 375.01 -Solve time = 0.00 -Solve flops = 1.734800e+04 Mflops = 481.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0506639; expected ratio = 0.0001obtained abs = 0.000816359; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.231177; expected ratio = 0.001obtained abs = 103.999; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.987160e+05 Mflops = 379.89 -Solve time = 0.00 -Solve flops = 1.743000e+04 Mflops = 484.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00535041; expected ratio = 0.0001obtained abs = 8.58028e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.652693; expected ratio = 0.001obtained abs = 314.201; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981320e+05 Mflops = 378.77 -Solve time = 0.00 -Solve flops = 1.740200e+04 Mflops = 483.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000914241; expected ratio = 0.0001obtained abs = 1.46668e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.533319; expected ratio = 0.001obtained abs = 233.495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981320e+05 Mflops = 377.40 -Solve time = 0.00 -Solve flops = 1.740200e+04 Mflops = 496.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000428325; expected ratio = 0.0001obtained abs = 6.87195e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1606; expected ratio = 0.001obtained abs = 70.1122; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.992840e+05 Mflops = 379.59 -Solve time = 0.00 -Solve flops = 1.743400e+04 Mflops = 484.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000299077; expected ratio = 0.0001obtained abs = 4.79874e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155058; expected ratio = 0.001obtained abs = 67.6498; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.992840e+05 Mflops = 379.59 -Solve time = 0.00 -Solve flops = 1.743400e+04 Mflops = 484.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000371406; expected ratio = 0.0001obtained abs = 5.95977e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19654; expected ratio = 0.001obtained abs = 85.6937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.992040e+05 Mflops = 379.44 -Solve time = 0.00 -Solve flops = 1.743000e+04 Mflops = 484.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00042345; expected ratio = 0.0001obtained abs = 6.79546e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.157267; expected ratio = 0.001obtained abs = 68.2482; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 377.93 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 499.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000459026; expected ratio = 0.0001obtained abs = 7.36673e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0411779; expected ratio = 0.001obtained abs = 17.8242; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 377.24 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000378537; expected ratio = 0.0001obtained abs = 6.07541e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0530758; expected ratio = 0.001obtained abs = 23.0142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 377.93 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 483.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000408013; expected ratio = 0.0001obtained abs = 6.54867e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0602677; expected ratio = 0.001obtained abs = 26.1491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 377.93 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000262699; expected ratio = 0.0001obtained abs = 4.21653e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0678999; expected ratio = 0.001obtained abs = 29.3977; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 377.93 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 483.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000230058; expected ratio = 0.0001obtained abs = 3.69271e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0856365; expected ratio = 0.001obtained abs = 37.1504; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 377.24 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 499.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00024822; expected ratio = 0.0001obtained abs = 3.98432e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.15026; expected ratio = 0.001obtained abs = 65.2425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 378.10 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000197682; expected ratio = 0.0001obtained abs = 3.17313e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.167808; expected ratio = 0.001obtained abs = 72.73; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.988120e+05 Mflops = 379.38 -Solve time = 0.00 -Solve flops = 1.743600e+04 Mflops = 484.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000231061; expected ratio = 0.0001obtained abs = 3.70897e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139168; expected ratio = 0.001obtained abs = 60.31; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438213 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 377.24 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00021337; expected ratio = 0.0001obtained abs = 3.42501e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.165391; expected ratio = 0.001obtained abs = 71.7018; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.988120e+05 Mflops = 379.38 -Solve time = 0.00 -Solve flops = 1.743600e+04 Mflops = 497.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000228826; expected ratio = 0.0001obtained abs = 3.67319e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.202002; expected ratio = 0.001obtained abs = 87.7669; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 368.87 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 483.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000218883; expected ratio = 0.0001obtained abs = 3.51359e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.22988; expected ratio = 0.001obtained abs = 99.8642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.988120e+05 Mflops = 379.38 -Solve time = 0.00 -Solve flops = 1.743600e+04 Mflops = 484.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000207535; expected ratio = 0.0001obtained abs = 3.33147e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.226363; expected ratio = 0.001obtained abs = 98.2697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980520e+05 Mflops = 377.93 -Solve time = 0.00 -Solve flops = 1.739800e+04 Mflops = 496.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00018862; expected ratio = 0.0001obtained abs = 3.02784e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.198329; expected ratio = 0.001obtained abs = 85.9009; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 63.3157 - Final Residual ratio : 0.0618458 - Residual ratio : 0.000976784 - Slope : -2.53015 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6271 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 121.387 - Final Residual ratio : 0.0765885 - Residual ratio : 0.000630942 - Slope : -5.05462 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 133.714 - Final Residual ratio : 0.116115 - Residual ratio : 0.000868383 - Slope : -5.56656 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 104.425 - Final Residual ratio : 0.0614484 - Residual ratio : 0.000588443 - Slope : -4.34849 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 60.6712 - Final Residual ratio : 0.0437117 - Residual ratio : 0.000720469 - Slope : -2.0906 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.271 - Final Residual ratio : 0.0359038 - Residual ratio : 0.000686879 - Slope : -1.86554 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.4966 - Final Residual ratio : 0.0357549 - Residual ratio : 0.000493194 - Slope : -2.49865 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 76.2867 - Final Residual ratio : 0.0703955 - Residual ratio : 0.000922776 - Slope : -4.23424 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 59.1037 - Final Residual ratio : 0.0571393 - Residual ratio : 0.000966764 - Slope : -2.46027 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.0061 - Final Residual ratio : 0.0220078 - Residual ratio : 0.000611225 - Slope : -1.43937 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 124 - - Mesh vertices: 114 - Mesh triangles: 124 - Mesh edges: 203 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6351 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.964600e+05 Mflops = 374.89 -Solve time = 0.00 -Solve flops = 1.733400e+04 Mflops = 481.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0474967; expected ratio = 0.0001obtained abs = 0.000796724; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243096; expected ratio = 0.001obtained abs = 112.011; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.954080e+05 Mflops = 374.25 -Solve time = 0.00 -Solve flops = 1.727800e+04 Mflops = 496.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00615797; expected ratio = 0.0001obtained abs = 0.000102745; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.783127; expected ratio = 0.001obtained abs = 414.946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.950480e+05 Mflops = 373.05 -Solve time = 0.00 -Solve flops = 1.726800e+04 Mflops = 492.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00228711; expected ratio = 0.0001obtained abs = 3.81414e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.700645; expected ratio = 0.001obtained abs = 315.596; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.964040e+05 Mflops = 374.79 -Solve time = 0.00 -Solve flops = 1.731200e+04 Mflops = 497.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00133799; expected ratio = 0.0001obtained abs = 2.23022e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121564; expected ratio = 0.001obtained abs = 54.8206; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.964040e+05 Mflops = 376.33 -Solve time = 0.00 -Solve flops = 1.731200e+04 Mflops = 493.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000865911; expected ratio = 0.0001obtained abs = 1.44283e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0941011; expected ratio = 0.001obtained abs = 42.5589; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970620e+05 Mflops = 376.73 -Solve time = 0.00 -Solve flops = 1.734400e+04 Mflops = 481.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000600752; expected ratio = 0.0001obtained abs = 1.00079e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0914281; expected ratio = 0.001obtained abs = 41.3494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 366.26 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 493.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000475301; expected ratio = 0.0001obtained abs = 7.91657e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0866704; expected ratio = 0.001obtained abs = 39.3316; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 375.27 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 511.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000477298; expected ratio = 0.0001obtained abs = 7.94873e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0701255; expected ratio = 0.001obtained abs = 31.788; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 375.44 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 493.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000299293; expected ratio = 0.0001obtained abs = 4.98386e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0861822; expected ratio = 0.001obtained abs = 39.1985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.951500e+05 Mflops = 388.11 -Solve time = 0.00 -Solve flops = 1.727400e+04 Mflops = 521.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000307481; expected ratio = 0.0001obtained abs = 5.11975e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.142472; expected ratio = 0.001obtained abs = 64.9152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 374.59 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 507.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00022628; expected ratio = 0.0001obtained abs = 3.7675e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166689; expected ratio = 0.001obtained abs = 76.0567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.951500e+05 Mflops = 373.75 -Solve time = 0.00 -Solve flops = 1.727400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000276655; expected ratio = 0.0001obtained abs = 4.606e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.209782; expected ratio = 0.001obtained abs = 95.9599; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 371.88 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 493.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000308715; expected ratio = 0.0001obtained abs = 5.13964e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.179673; expected ratio = 0.001obtained abs = 81.846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 375.27 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 497.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000415713; expected ratio = 0.0001obtained abs = 6.92075e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129663; expected ratio = 0.001obtained abs = 58.9546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970620e+05 Mflops = 378.28 -Solve time = 0.00 -Solve flops = 1.734400e+04 Mflops = 494.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000998451; expected ratio = 0.0001obtained abs = 1.66221e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0933367; expected ratio = 0.001obtained abs = 42.42; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 374.59 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 493.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000787892; expected ratio = 0.0001obtained abs = 1.3117e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0200798; expected ratio = 0.001obtained abs = 9.11386; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 374.59 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 493.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000574729; expected ratio = 0.0001obtained abs = 9.56854e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0214135; expected ratio = 0.001obtained abs = 9.73232; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 374.59 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 497.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00039612; expected ratio = 0.0001obtained abs = 6.59484e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00785426; expected ratio = 0.001obtained abs = 3.57012; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 375.27 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 493.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000185254; expected ratio = 0.0001obtained abs = 3.08421e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00945561; expected ratio = 0.001obtained abs = 4.29833; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.963020e+05 Mflops = 368.88 -Solve time = 0.00 -Solve flops = 1.730600e+04 Mflops = 497.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000187475; expected ratio = 0.0001obtained abs = 3.12117e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.017135; expected ratio = 0.001obtained abs = 7.79567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.1578 - Final Residual ratio : 0.0319493 - Residual ratio : 0.000859826 - Slope : -1.37503 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.0716 - Final Residual ratio : 0.0316866 - Residual ratio : 0.000608519 - Slope : -1.73466 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 55.4682 - Final Residual ratio : 0.0377423 - Residual ratio : 0.000680431 - Slope : -1.97966 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 44.6746 - Final Residual ratio : 0.025616 - Residual ratio : 0.000573391 - Slope : -1.53962 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.0535 - Final Residual ratio : 0.0296783 - Residual ratio : 0.000987515 - Slope : -1.30539 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.2793 - Final Residual ratio : 0.0189993 - Residual ratio : 0.000607408 - Slope : -1.11644 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.5073 - Final Residual ratio : 0.0241949 - Residual ratio : 0.000582906 - Slope : -1.43045 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.7166 - Final Residual ratio : 0.0346389 - Residual ratio : 0.000792351 - Slope : -1.45607 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.2108 - Final Residual ratio : 0.0265481 - Residual ratio : 0.000753977 - Slope : -1.67544 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.0248 - Final Residual ratio : 0.0182664 - Residual ratio : 0.000793335 - Slope : -0.766883 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6451 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.921940e+05 Mflops = 368.93 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0413387; expected ratio = 0.0001obtained abs = 0.000708598; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0450854; expected ratio = 0.001obtained abs = 20.424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.947340e+05 Mflops = 369.58 -Solve time = 0.00 -Solve flops = 1.719000e+04 Mflops = 504.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00732959; expected ratio = 0.0001obtained abs = 0.000125458; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0233778; expected ratio = 0.001obtained abs = 10.683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.944700e+05 Mflops = 365.61 -Solve time = 0.00 -Solve flops = 1.717600e+04 Mflops = 490.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00326003; expected ratio = 0.0001obtained abs = 5.57409e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.034882; expected ratio = 0.001obtained abs = 15.9239; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.935900e+05 Mflops = 373.67 -Solve time = 0.00 -Solve flops = 1.713200e+04 Mflops = 506.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00135046; expected ratio = 0.0001obtained abs = 2.3097e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0175837; expected ratio = 0.001obtained abs = 8.0363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.932240e+05 Mflops = 372.27 -Solve time = 0.00 -Solve flops = 1.711200e+04 Mflops = 501.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000820298; expected ratio = 0.0001obtained abs = 1.4025e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00508634; expected ratio = 0.001obtained abs = 2.32409; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.932240e+05 Mflops = 372.27 -Solve time = 0.00 -Solve flops = 1.711200e+04 Mflops = 501.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000506349; expected ratio = 0.0001obtained abs = 8.65859e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00420812; expected ratio = 0.001obtained abs = 1.92273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.932240e+05 Mflops = 372.44 -Solve time = 0.00 -Solve flops = 1.711200e+04 Mflops = 501.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000351645; expected ratio = 0.0001obtained abs = 6.01264e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00839615; expected ratio = 0.001obtained abs = 3.83685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.932240e+05 Mflops = 372.96 -Solve time = 0.00 -Solve flops = 1.711200e+04 Mflops = 501.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000321445; expected ratio = 0.0001obtained abs = 5.49676e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0132668; expected ratio = 0.001obtained abs = 6.05521; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.931440e+05 Mflops = 372.98 -Solve time = 0.00 -Solve flops = 1.710800e+04 Mflops = 501.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000259967; expected ratio = 0.0001obtained abs = 4.44548e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00600458; expected ratio = 0.001obtained abs = 2.74038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.942700e+05 Mflops = 365.89 -Solve time = 0.00 -Solve flops = 1.716600e+04 Mflops = 503.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000244172; expected ratio = 0.0001obtained abs = 4.17563e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102949; expected ratio = 0.001obtained abs = 4.70087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.935100e+05 Mflops = 374.37 -Solve time = 0.00 -Solve flops = 1.712800e+04 Mflops = 488.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000288662; expected ratio = 0.0001obtained abs = 4.93649e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211792; expected ratio = 0.001obtained abs = 9.65469; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.935100e+05 Mflops = 373.51 -Solve time = 0.00 -Solve flops = 1.712800e+04 Mflops = 505.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000247742; expected ratio = 0.0001obtained abs = 4.23688e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103122; expected ratio = 0.001obtained abs = 4.70178; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.935100e+05 Mflops = 373.51 -Solve time = 0.00 -Solve flops = 1.712800e+04 Mflops = 505.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000155931; expected ratio = 0.0001obtained abs = 2.66678e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0043631; expected ratio = 0.001obtained abs = 1.98978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.935100e+05 Mflops = 372.82 -Solve time = 0.00 -Solve flops = 1.712800e+04 Mflops = 505.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000152635; expected ratio = 0.0001obtained abs = 2.61046e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00270933; expected ratio = 0.001obtained abs = 1.23529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.945760e+05 Mflops = 374.88 -Solve time = 0.00 -Solve flops = 1.718400e+04 Mflops = 504.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000157295; expected ratio = 0.0001obtained abs = 2.69021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0109528; expected ratio = 0.001obtained abs = 4.99787; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.954560e+05 Mflops = 376.75 -Solve time = 0.00 -Solve flops = 1.722800e+04 Mflops = 491.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000258895; expected ratio = 0.0001obtained abs = 4.4279e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0213741; expected ratio = 0.001obtained abs = 9.73561; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.954560e+05 Mflops = 375.88 -Solve time = 0.00 -Solve flops = 1.722800e+04 Mflops = 505.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000216582; expected ratio = 0.0001obtained abs = 3.70429e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00871479; expected ratio = 0.001obtained abs = 3.97123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.945760e+05 Mflops = 375.74 -Solve time = 0.00 -Solve flops = 1.718400e+04 Mflops = 490.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000121056; expected ratio = 0.0001obtained abs = 2.07049e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00391761; expected ratio = 0.001obtained abs = 1.78556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.954560e+05 Mflops = 377.27 -Solve time = 0.00 -Solve flops = 1.722800e+04 Mflops = 508.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.18282e-05; expected ratio = 0.0001obtained abs = 1.5706e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00205781; expected ratio = 0.001obtained abs = 0.937838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.7783 - Final Residual ratio : 0.0219476 - Residual ratio : 0.000963531 - Slope : -0.910253 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.6305 - Final Residual ratio : 0.0282901 - Residual ratio : 0.000894394 - Slope : -1.08973 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.8785 - Final Residual ratio : 0.0252753 - Residual ratio : 0.000724666 - Slope : -1.20184 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.399 - Final Residual ratio : 0.0290852 - Residual ratio : 0.000989325 - Slope : -1.04893 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.614 - Final Residual ratio : 0.0151235 - Residual ratio : 0.000771058 - Slope : -0.653295 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.8522 - Final Residual ratio : 0.0102931 - Residual ratio : 0.000576571 - Slope : -0.686228 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.905 - Final Residual ratio : 0.0215789 - Residual ratio : 0.000866449 - Slope : -0.921608 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.5589 - Final Residual ratio : 0.0178402 - Residual ratio : 0.00062468 - Slope : -0.984176 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.1678 - Final Residual ratio : 0.022058 - Residual ratio : 0.000876437 - Slope : -0.785806 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.441 - Final Residual ratio : 0.0137231 - Residual ratio : 0.00078683 - Slope : -0.622402 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 19 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6551 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000476122 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.962060e+05 Mflops = 376.64 -Solve time = 0.00 -Solve flops = 1.727600e+04 Mflops = 492.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0378634; expected ratio = 0.0001obtained abs = 0.000665135; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0222094; expected ratio = 0.001obtained abs = 10.2403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.929960e+05 Mflops = 372.52 -Solve time = 0.00 -Solve flops = 1.710800e+04 Mflops = 488.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00757087; expected ratio = 0.0001obtained abs = 0.000132405; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0124909; expected ratio = 0.001obtained abs = 5.76548; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 370.50 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 504.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0024945; expected ratio = 0.0001obtained abs = 4.36567e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161182; expected ratio = 0.001obtained abs = 7.45686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.925760e+05 Mflops = 371.88 -Solve time = 0.00 -Solve flops = 1.708400e+04 Mflops = 501.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00157987; expected ratio = 0.0001obtained abs = 2.76349e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0274327; expected ratio = 0.001obtained abs = 12.636; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.86 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 504.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000900322; expected ratio = 0.0001obtained abs = 1.5754e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00841385; expected ratio = 0.001obtained abs = 3.87523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 372.03 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 501.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000543645; expected ratio = 0.0001obtained abs = 9.51172e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00560837; expected ratio = 0.001obtained abs = 2.57955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000477076 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.86 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 504.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000434248; expected ratio = 0.0001obtained abs = 7.59926e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0029577; expected ratio = 0.001obtained abs = 1.35925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.86 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 504.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000282946; expected ratio = 0.0001obtained abs = 4.95154e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00510776; expected ratio = 0.001obtained abs = 2.34498; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.86 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 504.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000331345; expected ratio = 0.0001obtained abs = 5.79925e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0135022; expected ratio = 0.001obtained abs = 6.2014; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.86 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 490.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000378979; expected ratio = 0.0001obtained abs = 6.63312e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0323977; expected ratio = 0.001obtained abs = 14.8307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.86 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000368291; expected ratio = 0.0001obtained abs = 6.44662e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00716847; expected ratio = 0.001obtained abs = 3.28115; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.86 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 490.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000286984; expected ratio = 0.0001obtained abs = 5.02357e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00981604; expected ratio = 0.001obtained abs = 4.49236; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.18 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 504.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000288081; expected ratio = 0.0001obtained abs = 5.04303e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00571548; expected ratio = 0.001obtained abs = 2.61422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478983 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 362.85 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000301337; expected ratio = 0.0001obtained abs = 5.27525e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0089856; expected ratio = 0.001obtained abs = 4.10936; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.18 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 504.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000304488; expected ratio = 0.0001obtained abs = 5.33062e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00502831; expected ratio = 0.001obtained abs = 2.29852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.86 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 501.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000337963; expected ratio = 0.0001obtained abs = 5.91683e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0189538; expected ratio = 0.001obtained abs = 8.67141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.18 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 490.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000339529; expected ratio = 0.0001obtained abs = 5.94441e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0287048; expected ratio = 0.001obtained abs = 13.1024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 370.50 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 504.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000320655; expected ratio = 0.0001obtained abs = 5.61412e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00856406; expected ratio = 0.001obtained abs = 3.90886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.18 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 501.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000312028; expected ratio = 0.0001obtained abs = 5.46319e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00668988; expected ratio = 0.001obtained abs = 3.05412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00047183 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926560e+05 Mflops = 371.18 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 501.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00031882; expected ratio = 0.0001obtained abs = 5.58221e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0045719; expected ratio = 0.001obtained abs = 2.08611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.9891 - Final Residual ratio : 0.0130913 - Residual ratio : 0.000935824 - Slope : -0.481931 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.2423 - Final Residual ratio : 0.0180273 - Residual ratio : 0.000936861 - Slope : -0.76897 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.2252 - Final Residual ratio : 0.011975 - Residual ratio : 0.000515603 - Slope : -0.800456 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.6753 - Final Residual ratio : 0.0169533 - Residual ratio : 0.000782147 - Slope : -0.721946 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.8242 - Final Residual ratio : 0.0151618 - Residual ratio : 0.000958137 - Slope : -0.54514 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.912 - Final Residual ratio : 0.00865609 - Residual ratio : 0.000726668 - Slope : -0.425121 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.141 - Final Residual ratio : 0.0118286 - Residual ratio : 0.000781233 - Slope : -0.58189 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.8142 - Final Residual ratio : 0.012536 - Residual ratio : 0.000666303 - Slope : -0.626722 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.3585 - Final Residual ratio : 0.0177734 - Residual ratio : 0.000968128 - Slope : -0.632438 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.1441 - Final Residual ratio : 0.0122297 - Residual ratio : 0.000864652 - Slope : -0.523401 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6651 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.043770e+05 Mflops = 385.61 -Solve time = 0.00 -Solve flops = 1.763000e+04 Mflops = 489.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0353818; expected ratio = 0.0001obtained abs = 0.000636099; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0241633; expected ratio = 0.001obtained abs = 11.0673; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.027810e+05 Mflops = 385.55 -Solve time = 0.00 -Solve flops = 1.755000e+04 Mflops = 500.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00413243; expected ratio = 0.0001obtained abs = 7.41871e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161826; expected ratio = 0.001obtained abs = 7.40875; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.030050e+05 Mflops = 380.12 -Solve time = 0.00 -Solve flops = 1.756400e+04 Mflops = 501.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00157979; expected ratio = 0.0001obtained abs = 2.8367e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0247561; expected ratio = 0.001obtained abs = 11.3033; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.030050e+05 Mflops = 385.98 -Solve time = 0.00 -Solve flops = 1.756400e+04 Mflops = 501.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000896551; expected ratio = 0.0001obtained abs = 1.61034e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0343349; expected ratio = 0.001obtained abs = 15.5749; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.030050e+05 Mflops = 385.98 -Solve time = 0.00 -Solve flops = 1.756400e+04 Mflops = 501.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000750449; expected ratio = 0.0001obtained abs = 1.34822e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00945881; expected ratio = 0.001obtained abs = 4.28025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.030050e+05 Mflops = 385.80 -Solve time = 0.00 -Solve flops = 1.756400e+04 Mflops = 504.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000627736; expected ratio = 0.0001obtained abs = 1.12798e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00790151; expected ratio = 0.001obtained abs = 3.56515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 386.45 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000616162; expected ratio = 0.0001obtained abs = 1.10738e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00581435; expected ratio = 0.001obtained abs = 2.61836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 386.45 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000557404; expected ratio = 0.0001obtained abs = 1.0019e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0257968; expected ratio = 0.001obtained abs = 11.6101; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467777 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 384.88 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000575641; expected ratio = 0.0001obtained abs = 1.03482e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0437787; expected ratio = 0.001obtained abs = 19.6248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 379.89 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000492806; expected ratio = 0.0001obtained abs = 8.85977e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.011959; expected ratio = 0.001obtained abs = 5.35335; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 385.75 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000512719; expected ratio = 0.0001obtained abs = 9.21868e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00830942; expected ratio = 0.001obtained abs = 3.71864; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 385.75 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000481206; expected ratio = 0.0001obtained abs = 8.65249e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00604991; expected ratio = 0.001obtained abs = 2.70306; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 386.45 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00047887; expected ratio = 0.0001obtained abs = 8.61115e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0281854; expected ratio = 0.001obtained abs = 12.6132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 385.75 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000475926; expected ratio = 0.0001obtained abs = 8.55849e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0440943; expected ratio = 0.001obtained abs = 19.6516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 386.45 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000484022; expected ratio = 0.0001obtained abs = 8.7046e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0294253; expected ratio = 0.001obtained abs = 13.1331; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 386.45 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 518.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000457445; expected ratio = 0.0001obtained abs = 8.22676e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119757; expected ratio = 0.001obtained abs = 5.33569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475883 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 380.06 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000435295; expected ratio = 0.0001obtained abs = 7.82883e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0914218; expected ratio = 0.001obtained abs = 41.1135; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 386.45 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000460982; expected ratio = 0.0001obtained abs = 8.2909e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.225558; expected ratio = 0.001obtained abs = 100.543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 385.57 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 504.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000528657; expected ratio = 0.0001obtained abs = 9.50865e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125081; expected ratio = 0.001obtained abs = 55.6387; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028850e+05 Mflops = 386.45 -Solve time = 0.00 -Solve flops = 1.755800e+04 Mflops = 500.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000467971; expected ratio = 0.0001obtained abs = 8.41716e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00992218; expected ratio = 0.001obtained abs = 4.4084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1978 - Final Residual ratio : 0.00790326 - Residual ratio : 0.000774996 - Slope : -0.363925 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0339 - Final Residual ratio : 0.00880624 - Residual ratio : 0.000731786 - Slope : -0.445374 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.4138 - Final Residual ratio : 0.0130636 - Residual ratio : 0.000847529 - Slope : -0.531059 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.9084 - Final Residual ratio : 0.00938775 - Residual ratio : 0.000590113 - Slope : -0.548241 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.9392 - Final Residual ratio : 0.0100448 - Residual ratio : 0.000720609 - Slope : -0.515896 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.23812 - Final Residual ratio : 0.00752457 - Residual ratio : 0.000814513 - Slope : -0.329664 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.81917 - Final Residual ratio : 0.00795539 - Residual ratio : 0.00081019 - Slope : -0.32704 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.6415 - Final Residual ratio : 0.0122625 - Residual ratio : 0.000970025 - Slope : -0.43549 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.385 - Final Residual ratio : 0.0107281 - Residual ratio : 0.000801501 - Slope : -0.477653 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.2696 - Final Residual ratio : 0.00976449 - Residual ratio : 0.000866443 - Slope : -0.417032 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6751 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 389.14 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 501.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0372783; expected ratio = 0.0001obtained abs = 0.000692038; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0323084; expected ratio = 0.001obtained abs = 14.4654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.030930e+05 Mflops = 388.97 -Solve time = 0.00 -Solve flops = 1.756400e+04 Mflops = 504.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00431853; expected ratio = 0.0001obtained abs = 7.99305e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0192373; expected ratio = 0.001obtained abs = 8.60436; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 390.57 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 501.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0012325; expected ratio = 0.0001obtained abs = 2.28249e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0379351; expected ratio = 0.001obtained abs = 16.9737; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.036690e+05 Mflops = 390.96 -Solve time = 0.00 -Solve flops = 1.759600e+04 Mflops = 516.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000796107; expected ratio = 0.0001obtained abs = 1.47439e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.04477; expected ratio = 0.001obtained abs = 19.8956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000476837 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 382.35 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 505.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000689629; expected ratio = 0.0001obtained abs = 1.27751e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0308419; expected ratio = 0.001obtained abs = 13.7042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 385.28 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 505.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000627015; expected ratio = 0.0001obtained abs = 1.16163e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0192786; expected ratio = 0.001obtained abs = 8.5293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 390.39 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 505.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000582788; expected ratio = 0.0001obtained abs = 1.07989e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100306; expected ratio = 0.001obtained abs = 44.77; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 389.86 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 501.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000562913; expected ratio = 0.0001obtained abs = 1.04313e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.203101; expected ratio = 0.001obtained abs = 89.5487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 390.57 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 501.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00054934; expected ratio = 0.0001obtained abs = 1.01813e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131885; expected ratio = 0.001obtained abs = 58.2186; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 389.86 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 501.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000533001; expected ratio = 0.0001obtained abs = 9.87897e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0651977; expected ratio = 0.001obtained abs = 28.6196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 389.86 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 501.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000504752; expected ratio = 0.0001obtained abs = 9.3563e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.032131; expected ratio = 0.001obtained abs = 14.1153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.031590e+05 Mflops = 381.09 -Solve time = 0.00 -Solve flops = 1.756600e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000480981; expected ratio = 0.0001obtained abs = 8.91594e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106883; expected ratio = 0.001obtained abs = 4.68794; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 385.45 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 488.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000445173; expected ratio = 0.0001obtained abs = 8.25285e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0101069; expected ratio = 0.001obtained abs = 4.43218; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.031590e+05 Mflops = 389.80 -Solve time = 0.00 -Solve flops = 1.756600e+04 Mflops = 504.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00047406; expected ratio = 0.0001obtained abs = 8.78861e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0950929; expected ratio = 0.001obtained abs = 42; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 390.57 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 488.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000487192; expected ratio = 0.0001obtained abs = 9.03265e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.2296; expected ratio = 0.001obtained abs = 100.825; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.031590e+05 Mflops = 390.70 -Solve time = 0.00 -Solve flops = 1.756600e+04 Mflops = 504.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00048581; expected ratio = 0.0001obtained abs = 9.00727e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159549; expected ratio = 0.001obtained abs = 69.8304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 391.29 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 505.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000564315; expected ratio = 0.0001obtained abs = 1.04633e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0718274; expected ratio = 0.001obtained abs = 31.3694; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.031590e+05 Mflops = 390.70 -Solve time = 0.00 -Solve flops = 1.756600e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000549435; expected ratio = 0.0001obtained abs = 1.01878e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0597627; expected ratio = 0.001obtained abs = 26.1072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.034650e+05 Mflops = 376.11 -Solve time = 0.00 -Solve flops = 1.758400e+04 Mflops = 488.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000537066; expected ratio = 0.0001obtained abs = 9.95896e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0239438; expected ratio = 0.001obtained abs = 10.4532; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.040090e+05 Mflops = 391.61 -Solve time = 0.00 -Solve flops = 1.760000e+04 Mflops = 502.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000506591; expected ratio = 0.0001obtained abs = 9.39396e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0270488; expected ratio = 0.001obtained abs = 11.8015; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.96448 - Final Residual ratio : 0.0056155 - Residual ratio : 0.000705068 - Slope : -0.294773 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.76171 - Final Residual ratio : 0.00745629 - Residual ratio : 0.00096065 - Slope : -0.31017 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.2404 - Final Residual ratio : 0.00611392 - Residual ratio : 0.000597037 - Slope : -0.379049 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.3931 - Final Residual ratio : 0.00970719 - Residual ratio : 0.00085202 - Slope : -0.421609 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.99402 - Final Residual ratio : 0.00678006 - Residual ratio : 0.000678411 - Slope : -0.344388 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.23663 - Final Residual ratio : 0.00661768 - Residual ratio : 0.00091447 - Slope : -0.267778 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.2576 - Final Residual ratio : 0.0282834 - Residual ratio : 0.000876797 - Slope : -1.34289 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.6489 - Final Residual ratio : 0.0134365 - Residual ratio : 0.000917237 - Slope : -0.562901 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4806 - Final Residual ratio : 0.00928537 - Residual ratio : 0.000885959 - Slope : -0.349043 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.50499 - Final Residual ratio : 0.00834693 - Residual ratio : 0.000878163 - Slope : -0.32747 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6851 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000488043 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.024950e+05 Mflops = 376.47 -Solve time = 0.00 -Solve flops = 1.753000e+04 Mflops = 500.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0360979; expected ratio = 0.0001obtained abs = 0.000691282; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0403162; expected ratio = 0.001obtained abs = 17.8259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.028650e+05 Mflops = 388.71 -Solve time = 0.00 -Solve flops = 1.754400e+04 Mflops = 500.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00402173; expected ratio = 0.0001obtained abs = 7.67959e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0696689; expected ratio = 0.001obtained abs = 30.8578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.024950e+05 Mflops = 388.00 -Solve time = 0.00 -Solve flops = 1.753000e+04 Mflops = 500.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00142575; expected ratio = 0.0001obtained abs = 2.72226e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0264161; expected ratio = 0.001obtained abs = 11.7347; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.021890e+05 Mflops = 388.12 -Solve time = 0.00 -Solve flops = 1.751200e+04 Mflops = 486.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000756083; expected ratio = 0.0001obtained abs = 1.44358e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0207536; expected ratio = 0.001obtained abs = 9.2143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.024950e+05 Mflops = 388.00 -Solve time = 0.00 -Solve flops = 1.753000e+04 Mflops = 514.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000530247; expected ratio = 0.0001obtained abs = 1.0124e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.025596; expected ratio = 0.001obtained abs = 11.364; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.021890e+05 Mflops = 387.41 -Solve time = 0.00 -Solve flops = 1.751200e+04 Mflops = 499.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000555344; expected ratio = 0.0001obtained abs = 1.06033e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.114884; expected ratio = 0.001obtained abs = 51.4508; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475168 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.024950e+05 Mflops = 388.00 -Solve time = 0.00 -Solve flops = 1.753000e+04 Mflops = 500.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000539747; expected ratio = 0.0001obtained abs = 1.03062e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.204255; expected ratio = 0.001obtained abs = 90.5962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.021890e+05 Mflops = 378.59 -Solve time = 0.00 -Solve flops = 1.751200e+04 Mflops = 499.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000520888; expected ratio = 0.0001obtained abs = 9.94642e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120957; expected ratio = 0.001obtained abs = 53.5838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.024950e+05 Mflops = 388.00 -Solve time = 0.00 -Solve flops = 1.753000e+04 Mflops = 514.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000505839; expected ratio = 0.0001obtained abs = 9.65976e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0150529; expected ratio = 0.001obtained abs = 6.673; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.021890e+05 Mflops = 387.41 -Solve time = 0.00 -Solve flops = 1.751200e+04 Mflops = 499.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000495267; expected ratio = 0.0001obtained abs = 9.4581e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0159505; expected ratio = 0.001obtained abs = 7.0559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.024950e+05 Mflops = 387.11 -Solve time = 0.00 -Solve flops = 1.753000e+04 Mflops = 500.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000507889; expected ratio = 0.0001obtained abs = 9.69993e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0565415; expected ratio = 0.001obtained abs = 24.9491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.021890e+05 Mflops = 387.23 -Solve time = 0.00 -Solve flops = 1.751200e+04 Mflops = 503.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000460231; expected ratio = 0.0001obtained abs = 8.78995e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0166177; expected ratio = 0.001obtained abs = 7.31658; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.024950e+05 Mflops = 387.82 -Solve time = 0.00 -Solve flops = 1.753000e+04 Mflops = 500.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000433541; expected ratio = 0.0001obtained abs = 8.28079e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123282; expected ratio = 0.001obtained abs = 54.9579; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.021890e+05 Mflops = 387.41 -Solve time = 0.00 -Solve flops = 1.751200e+04 Mflops = 499.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000439743; expected ratio = 0.0001obtained abs = 8.39942e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.234659; expected ratio = 0.001obtained abs = 103.419; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.024950e+05 Mflops = 378.49 -Solve time = 0.00 -Solve flops = 1.753000e+04 Mflops = 500.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000421567; expected ratio = 0.0001obtained abs = 8.05291e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.150683; expected ratio = 0.001obtained abs = 66.4431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.021890e+05 Mflops = 388.12 -Solve time = 0.00 -Solve flops = 1.751200e+04 Mflops = 499.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000450324; expected ratio = 0.0001obtained abs = 8.6024e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0237172; expected ratio = 0.001obtained abs = 10.4196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.022910e+05 Mflops = 388.32 -Solve time = 0.00 -Solve flops = 1.751800e+04 Mflops = 513.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00052107; expected ratio = 0.0001obtained abs = 9.95443e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0540532; expected ratio = 0.001obtained abs = 23.7241; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.021890e+05 Mflops = 387.41 -Solve time = 0.00 -Solve flops = 1.751200e+04 Mflops = 499.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000452042; expected ratio = 0.0001obtained abs = 8.636e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0435451; expected ratio = 0.001obtained abs = 19.0984; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.022910e+05 Mflops = 387.61 -Solve time = 0.00 -Solve flops = 1.751800e+04 Mflops = 499.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000398489; expected ratio = 0.0001obtained abs = 7.61335e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0423108; expected ratio = 0.001obtained abs = 18.6267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.019850e+05 Mflops = 386.84 -Solve time = 0.00 -Solve flops = 1.750000e+04 Mflops = 486.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000386825; expected ratio = 0.0001obtained abs = 7.39061e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0604672; expected ratio = 0.001obtained abs = 26.457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.6446 - Final Residual ratio : 0.00751978 - Residual ratio : 0.000983673 - Slope : -0.318212 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.47262 - Final Residual ratio : 0.00451877 - Residual ratio : 0.000825706 - Slope : -0.260386 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.06588 - Final Residual ratio : 0.00537221 - Residual ratio : 0.000760304 - Slope : -0.271558 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.54681 - Final Residual ratio : 0.00819297 - Residual ratio : 0.0009586 - Slope : -0.294435 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.24319 - Final Residual ratio : 0.00712242 - Residual ratio : 0.000864036 - Slope : -0.316772 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.50447 - Final Residual ratio : 0.00512185 - Residual ratio : 0.000787436 - Slope : -0.240717 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.88855 - Final Residual ratio : 0.00469201 - Residual ratio : 0.000959795 - Slope : -0.203494 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.55312 - Final Residual ratio : 0.00438979 - Residual ratio : 0.00079051 - Slope : -0.178991 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.91909 - Final Residual ratio : 0.00556708 - Residual ratio : 0.000804597 - Slope : -0.230451 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.1205 - Final Residual ratio : 0.00564352 - Residual ratio : 0.000792574 - Slope : -0.254102 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.6951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.6951 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.953090e+05 Mflops = 379.25 -Solve time = 0.00 -Solve flops = 1.718000e+04 Mflops = 490.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0343625; expected ratio = 0.0001obtained abs = 0.000676586; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0426064; expected ratio = 0.001obtained abs = 19.067; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.946630e+05 Mflops = 380.82 -Solve time = 0.00 -Solve flops = 1.713800e+04 Mflops = 488.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00430732; expected ratio = 0.0001obtained abs = 8.44987e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0499644; expected ratio = 0.001obtained abs = 22.6592; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.940310e+05 Mflops = 379.58 -Solve time = 0.00 -Solve flops = 1.711000e+04 Mflops = 488.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00177458; expected ratio = 0.0001obtained abs = 3.48024e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0795981; expected ratio = 0.001obtained abs = 36.1669; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.937250e+05 Mflops = 379.16 -Solve time = 0.00 -Solve flops = 1.709200e+04 Mflops = 501.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000999934; expected ratio = 0.0001obtained abs = 1.96035e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0230855; expected ratio = 0.001obtained abs = 10.4966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.942970e+05 Mflops = 380.10 -Solve time = 0.00 -Solve flops = 1.712400e+04 Mflops = 505.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000579921; expected ratio = 0.0001obtained abs = 1.13675e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0440771; expected ratio = 0.001obtained abs = 20.1459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.939230e+05 Mflops = 373.62 -Solve time = 0.00 -Solve flops = 1.710400e+04 Mflops = 488.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000545023; expected ratio = 0.0001obtained abs = 1.06822e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0533434; expected ratio = 0.001obtained abs = 24.4402; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.942290e+05 Mflops = 379.26 -Solve time = 0.00 -Solve flops = 1.712200e+04 Mflops = 491.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000438782; expected ratio = 0.0001obtained abs = 8.59965e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0796746; expected ratio = 0.001obtained abs = 36.4046; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.939230e+05 Mflops = 377.26 -Solve time = 0.00 -Solve flops = 1.710400e+04 Mflops = 501.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000446025; expected ratio = 0.0001obtained abs = 8.74148e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0240525; expected ratio = 0.001obtained abs = 10.959; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.940310e+05 Mflops = 379.76 -Solve time = 0.00 -Solve flops = 1.711000e+04 Mflops = 488.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000419966; expected ratio = 0.0001obtained abs = 8.23109e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0196907; expected ratio = 0.001obtained abs = 8.98578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.939230e+05 Mflops = 378.84 -Solve time = 0.00 -Solve flops = 1.710400e+04 Mflops = 501.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000432488; expected ratio = 0.0001obtained abs = 8.47669e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101551; expected ratio = 0.001obtained abs = 46.6203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.940310e+05 Mflops = 378.88 -Solve time = 0.00 -Solve flops = 1.711000e+04 Mflops = 488.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000425476; expected ratio = 0.0001obtained abs = 8.33987e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.220224; expected ratio = 0.001obtained abs = 100.585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.937250e+05 Mflops = 378.28 -Solve time = 0.00 -Solve flops = 1.709200e+04 Mflops = 487.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000400375; expected ratio = 0.0001obtained abs = 7.84823e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.215751; expected ratio = 0.001obtained abs = 98.8063; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.940310e+05 Mflops = 373.83 -Solve time = 0.00 -Solve flops = 1.711000e+04 Mflops = 488.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000421796; expected ratio = 0.0001obtained abs = 8.26877e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.209347; expected ratio = 0.001obtained abs = 95.3567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.937250e+05 Mflops = 379.16 -Solve time = 0.00 -Solve flops = 1.709200e+04 Mflops = 501.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000405167; expected ratio = 0.0001obtained abs = 7.94323e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.218124; expected ratio = 0.001obtained abs = 99.7721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.940310e+05 Mflops = 379.05 -Solve time = 0.00 -Solve flops = 1.711000e+04 Mflops = 501.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00045398; expected ratio = 0.0001obtained abs = 8.90095e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.235809; expected ratio = 0.001obtained abs = 107.329; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.937250e+05 Mflops = 379.16 -Solve time = 0.00 -Solve flops = 1.709200e+04 Mflops = 487.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000421542; expected ratio = 0.0001obtained abs = 8.26549e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.149909; expected ratio = 0.001obtained abs = 67.811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475168 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.940310e+05 Mflops = 379.05 -Solve time = 0.00 -Solve flops = 1.711000e+04 Mflops = 488.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000430705; expected ratio = 0.0001obtained abs = 8.44589e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0321241; expected ratio = 0.001obtained abs = 14.5699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475168 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.937250e+05 Mflops = 371.19 -Solve time = 0.00 -Solve flops = 1.709200e+04 Mflops = 487.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000374462; expected ratio = 0.0001obtained abs = 7.34337e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0407957; expected ratio = 0.001obtained abs = 18.4001; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.943310e+05 Mflops = 381.06 -Solve time = 0.00 -Solve flops = 1.713000e+04 Mflops = 488.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000379752; expected ratio = 0.0001obtained abs = 7.44779e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0166597; expected ratio = 0.001obtained abs = 7.51841; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.940250e+05 Mflops = 379.75 -Solve time = 0.00 -Solve flops = 1.711200e+04 Mflops = 488.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000378755; expected ratio = 0.0001obtained abs = 7.42862e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0279584; expected ratio = 0.001obtained abs = 12.57; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.6961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.72814 - Final Residual ratio : 0.00432592 - Residual ratio : 0.000755204 - Slope : -0.211993 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.10565 - Final Residual ratio : 0.00301056 - Residual ratio : 0.000733272 - Slope : -0.178375 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.33639 - Final Residual ratio : 0.00201779 - Residual ratio : 0.000465317 - Slope : -0.173375 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.6991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.68959 - Final Residual ratio : 0.00534939 - Residual ratio : 0.000940207 - Slope : -0.218625 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.6991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.13365 - Final Residual ratio : 0.00566486 - Residual ratio : 0.000923572 - Slope : -0.21131 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.32597 - Final Residual ratio : 0.00527069 - Residual ratio : 0.000989621 - Slope : -0.190025 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.82934 - Final Residual ratio : 0.00312314 - Residual ratio : 0.000815581 - Slope : -0.153049 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47566 - Final Residual ratio : 0.00191669 - Residual ratio : 0.000551461 - Slope : -0.133605 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.52936 - Final Residual ratio : 0.00311518 - Residual ratio : 0.000687776 - Slope : -0.146008 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.25131 - Final Residual ratio : 0.00272863 - Residual ratio : 0.000519611 - Slope : -0.164018 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7051 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.835200e+05 Mflops = 379.93 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 493.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0314383; expected ratio = 0.0001obtained abs = 0.000632295; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0536615; expected ratio = 0.001obtained abs = 24.3857; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.841740e+05 Mflops = 383.75 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00347399; expected ratio = 0.0001obtained abs = 6.97184e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0404672; expected ratio = 0.001obtained abs = 18.4218; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.844800e+05 Mflops = 383.62 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 477.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000862371; expected ratio = 0.0001obtained abs = 1.73112e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0570754; expected ratio = 0.001obtained abs = 25.9148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.847460e+05 Mflops = 384.17 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 491.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000592304; expected ratio = 0.0001obtained abs = 1.18906e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0515374; expected ratio = 0.001obtained abs = 23.2741; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.844800e+05 Mflops = 381.17 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 491.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000480159; expected ratio = 0.0001obtained abs = 9.64067e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0471585; expected ratio = 0.001obtained abs = 21.3165; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.841740e+05 Mflops = 382.80 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000475519; expected ratio = 0.0001obtained abs = 9.54853e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.026774; expected ratio = 0.001obtained abs = 12.0551; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.844800e+05 Mflops = 382.67 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 481.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000449536; expected ratio = 0.0001obtained abs = 9.02798e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0473683; expected ratio = 0.001obtained abs = 21.3868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.853600e+05 Mflops = 383.74 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 496.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0004349; expected ratio = 0.0001obtained abs = 8.7349e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0993489; expected ratio = 0.001obtained abs = 44.4196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.856260e+05 Mflops = 385.05 -Solve time = 0.00 -Solve flops = 1.680800e+04 Mflops = 496.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000486432; expected ratio = 0.0001obtained abs = 9.77125e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0431581; expected ratio = 0.001obtained abs = 19.3365; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.856260e+05 Mflops = 386.00 -Solve time = 0.00 -Solve flops = 1.680800e+04 Mflops = 492.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000427586; expected ratio = 0.0001obtained abs = 8.58991e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0269043; expected ratio = 0.001obtained abs = 11.9957; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.856260e+05 Mflops = 385.05 -Solve time = 0.00 -Solve flops = 1.680800e+04 Mflops = 479.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000402194; expected ratio = 0.0001obtained abs = 8.08071e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0359068; expected ratio = 0.001obtained abs = 16.0399; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.856260e+05 Mflops = 385.05 -Solve time = 0.00 -Solve flops = 1.680800e+04 Mflops = 479.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000370614; expected ratio = 0.0001obtained abs = 7.44686e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0408457; expected ratio = 0.001obtained abs = 18.2323; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478983 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.853600e+05 Mflops = 384.50 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 482.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000368712; expected ratio = 0.0001obtained abs = 7.40936e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0609394; expected ratio = 0.001obtained abs = 27.098; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000476837 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.850540e+05 Mflops = 375.33 -Solve time = 0.00 -Solve flops = 1.677600e+04 Mflops = 481.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000352077; expected ratio = 0.0001obtained abs = 7.07563e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0789896; expected ratio = 0.001obtained abs = 35.199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.853600e+05 Mflops = 384.69 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 492.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000413402; expected ratio = 0.0001obtained abs = 8.30878e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122949; expected ratio = 0.001obtained abs = 54.4532; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.850540e+05 Mflops = 383.86 -Solve time = 0.00 -Solve flops = 1.677600e+04 Mflops = 478.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000358585; expected ratio = 0.0001obtained abs = 7.20758e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0536168; expected ratio = 0.001obtained abs = 23.7002; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.853600e+05 Mflops = 378.32 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 479.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00038343; expected ratio = 0.0001obtained abs = 7.70755e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0603439; expected ratio = 0.001obtained abs = 26.797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.866060e+05 Mflops = 387.08 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000335648; expected ratio = 0.0001obtained abs = 6.74742e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125985; expected ratio = 0.001obtained abs = 55.4925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000677109 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.869120e+05 Mflops = 386.19 -Solve time = 0.00 -Solve flops = 1.687000e+04 Mflops = 498.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000356118; expected ratio = 0.0001obtained abs = 7.1595e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102019; expected ratio = 0.001obtained abs = 45.0972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.866060e+05 Mflops = 387.08 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 497.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000366169; expected ratio = 0.0001obtained abs = 7.3619e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0374602; expected ratio = 0.001obtained abs = 16.4752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.71109 - Final Residual ratio : 0.00248754 - Residual ratio : 0.000528018 - Slope : -0.162366 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.46772 - Final Residual ratio : 0.00254488 - Residual ratio : 0.000733877 - Slope : -0.138607 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84027 - Final Residual ratio : 0.00248321 - Residual ratio : 0.000874284 - Slope : -0.109146 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.65269 - Final Residual ratio : 0.00299928 - Residual ratio : 0.000821116 - Slope : -0.145988 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.39459 - Final Residual ratio : 0.00344687 - Residual ratio : 0.000784343 - Slope : -0.156826 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.27797 - Final Residual ratio : 0.00335027 - Residual ratio : 0.000783143 - Slope : -0.158319 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.32536 - Final Residual ratio : 0.00287391 - Residual ratio : 0.000864242 - Slope : -0.127788 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.49642 - Final Residual ratio : 0.00217591 - Residual ratio : 0.00087161 - Slope : -0.0890802 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.88921 - Final Residual ratio : 0.00213494 - Residual ratio : 0.000738937 - Slope : -0.0962358 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.68011 - Final Residual ratio : 0.00220982 - Residual ratio : 0.000600478 - Slope : -0.122597 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7151 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000477076 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.932680e+05 Mflops = 378.80 -Solve time = 0.00 -Solve flops = 1.707000e+04 Mflops = 428.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0313662; expected ratio = 0.0001obtained abs = 0.000647361; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0475504; expected ratio = 0.001obtained abs = 21.3515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.926780e+05 Mflops = 381.56 -Solve time = 0.00 -Solve flops = 1.704200e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00450033; expected ratio = 0.0001obtained abs = 9.25737e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0861318; expected ratio = 0.001obtained abs = 38.96; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.921040e+05 Mflops = 381.15 -Solve time = 0.00 -Solve flops = 1.701600e+04 Mflops = 485.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00212752; expected ratio = 0.0001obtained abs = 4.3749e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0543873; expected ratio = 0.001obtained abs = 24.814; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.921040e+05 Mflops = 380.43 -Solve time = 0.00 -Solve flops = 1.701600e+04 Mflops = 485.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00121771; expected ratio = 0.0001obtained abs = 2.50318e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0393348; expected ratio = 0.001obtained abs = 17.9205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.917980e+05 Mflops = 379.10 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000708197; expected ratio = 0.0001obtained abs = 1.45564e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0409247; expected ratio = 0.001obtained abs = 18.7433; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.917980e+05 Mflops = 375.39 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000668505; expected ratio = 0.0001obtained abs = 1.37396e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0749237; expected ratio = 0.001obtained abs = 34.4276; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.923700e+05 Mflops = 381.67 -Solve time = 0.00 -Solve flops = 1.703000e+04 Mflops = 485.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000537304; expected ratio = 0.0001obtained abs = 1.10432e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139553; expected ratio = 0.001obtained abs = 63.7957; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.917980e+05 Mflops = 379.82 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000558062; expected ratio = 0.0001obtained abs = 1.14701e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137804; expected ratio = 0.001obtained abs = 63.2139; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.923700e+05 Mflops = 381.67 -Solve time = 0.00 -Solve flops = 1.703000e+04 Mflops = 485.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000548321; expected ratio = 0.0001obtained abs = 1.12708e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145819; expected ratio = 0.001obtained abs = 66.5086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.917980e+05 Mflops = 380.54 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000543043; expected ratio = 0.0001obtained abs = 1.1163e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.150604; expected ratio = 0.001obtained abs = 68.9334; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.925300e+05 Mflops = 380.55 -Solve time = 0.00 -Solve flops = 1.703800e+04 Mflops = 486.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000568245; expected ratio = 0.0001obtained abs = 1.16823e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164196; expected ratio = 0.001obtained abs = 74.7014; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.917980e+05 Mflops = 379.10 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000543542; expected ratio = 0.0001obtained abs = 1.11752e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.173272; expected ratio = 0.001obtained abs = 79.1667; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.921040e+05 Mflops = 379.53 -Solve time = 0.00 -Solve flops = 1.701600e+04 Mflops = 488.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00058525; expected ratio = 0.0001obtained abs = 1.2034e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140568; expected ratio = 0.001obtained abs = 63.7184; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.917980e+05 Mflops = 380.72 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000549274; expected ratio = 0.0001obtained abs = 1.1295e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0415543; expected ratio = 0.001obtained abs = 18.7696; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.923700e+05 Mflops = 380.95 -Solve time = 0.00 -Solve flops = 1.703000e+04 Mflops = 485.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000580266; expected ratio = 0.0001obtained abs = 1.19336e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0194863; expected ratio = 0.001obtained abs = 8.80966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.917980e+05 Mflops = 379.82 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000519014; expected ratio = 0.0001obtained abs = 1.06744e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0235532; expected ratio = 0.001obtained abs = 10.6173; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000479221 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.921040e+05 Mflops = 380.43 -Solve time = 0.00 -Solve flops = 1.701600e+04 Mflops = 485.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000564073; expected ratio = 0.0001obtained abs = 1.16022e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0485649; expected ratio = 0.001obtained abs = 21.9832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.917980e+05 Mflops = 380.54 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00053332; expected ratio = 0.0001obtained abs = 1.09701e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0674188; expected ratio = 0.001obtained abs = 30.3023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.921040e+05 Mflops = 380.43 -Solve time = 0.00 -Solve flops = 1.701600e+04 Mflops = 485.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000543637; expected ratio = 0.0001obtained abs = 1.11833e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0515942; expected ratio = 0.001obtained abs = 23.2749; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.917980e+05 Mflops = 379.64 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 488.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000559628; expected ratio = 0.0001obtained abs = 1.15127e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0265167; expected ratio = 0.001obtained abs = 11.9176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.69312 - Final Residual ratio : 0.00364983 - Residual ratio : 0.000988278 - Slope : -0.122982 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.00644 - Final Residual ratio : 0.00240434 - Residual ratio : 0.000799732 - Slope : -0.111261 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.7181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.19277 - Final Residual ratio : 0.00144069 - Residual ratio : 0.000657017 - Slope : -0.0952753 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.32743 - Final Residual ratio : 0.00171954 - Residual ratio : 0.000738815 - Slope : -0.0894503 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7201 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.00174 - Final Residual ratio : 0.00233447 - Residual ratio : 0.000777705 - Slope : -0.111089 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.25851 - Final Residual ratio : 0.0028495 - Residual ratio : 0.000874478 - Slope : -0.0986565 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.8264 - Final Residual ratio : 0.00271595 - Residual ratio : 0.000960922 - Slope : -0.0973684 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08627 - Final Residual ratio : 0.00149806 - Residual ratio : 0.000718054 - Slope : -0.0833909 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.92172 - Final Residual ratio : 0.00169094 - Residual ratio : 0.00087991 - Slope : -0.0662078 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.48476 - Final Residual ratio : 0.00199381 - Residual ratio : 0.000802415 - Slope : -0.0827588 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7251 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000496149 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833400e+05 Mflops = 378.81 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 475.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0288863; expected ratio = 0.0001obtained abs = 0.000607452; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0588268; expected ratio = 0.001obtained abs = 26.1523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.839940e+05 Mflops = 385.67 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 479.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00607773; expected ratio = 0.0001obtained abs = 0.000127582; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0279919; expected ratio = 0.001obtained abs = 12.4356; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.843000e+05 Mflops = 384.58 -Solve time = 0.00 -Solve flops = 1.671000e+04 Mflops = 480.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00103764; expected ratio = 0.0001obtained abs = 2.17897e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.068513; expected ratio = 0.001obtained abs = 30.5689; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.851800e+05 Mflops = 386.61 -Solve time = 0.00 -Solve flops = 1.675400e+04 Mflops = 478.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00063804; expected ratio = 0.0001obtained abs = 1.33992e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0916118; expected ratio = 0.001obtained abs = 40.483; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.851800e+05 Mflops = 381.86 -Solve time = 0.00 -Solve flops = 1.675400e+04 Mflops = 478.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000502982; expected ratio = 0.0001obtained abs = 1.05644e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0712032; expected ratio = 0.001obtained abs = 31.5437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.851800e+05 Mflops = 385.65 -Solve time = 0.00 -Solve flops = 1.675400e+04 Mflops = 494.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000449861; expected ratio = 0.0001obtained abs = 9.4496e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.037997; expected ratio = 0.001obtained abs = 16.7304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475883 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.851800e+05 Mflops = 386.61 -Solve time = 0.00 -Solve flops = 1.675400e+04 Mflops = 478.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000419487; expected ratio = 0.0001obtained abs = 8.8127e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234734; expected ratio = 0.001obtained abs = 10.3366; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.851800e+05 Mflops = 377.22 -Solve time = 0.00 -Solve flops = 1.675400e+04 Mflops = 494.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000384082; expected ratio = 0.0001obtained abs = 8.06971e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0748858; expected ratio = 0.001obtained abs = 32.7829; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.867320e+05 Mflops = 388.30 -Solve time = 0.00 -Solve flops = 1.683000e+04 Mflops = 480.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000393033; expected ratio = 0.0001obtained abs = 8.2587e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0231293; expected ratio = 0.001obtained abs = 10.1125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.864260e+05 Mflops = 388.44 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 479.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000311299; expected ratio = 0.0001obtained abs = 6.5418e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0143548; expected ratio = 0.001obtained abs = 6.26232; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.864260e+05 Mflops = 387.67 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 479.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000330428; expected ratio = 0.0001obtained abs = 6.94444e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0110187; expected ratio = 0.001obtained abs = 4.80429; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.864260e+05 Mflops = 388.25 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 479.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00031498; expected ratio = 0.0001obtained abs = 6.62023e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0114567; expected ratio = 0.001obtained abs = 4.98172; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.864260e+05 Mflops = 388.25 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 482.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000448152; expected ratio = 0.0001obtained abs = 9.41998e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0873254; expected ratio = 0.001obtained abs = 38.2068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.864260e+05 Mflops = 388.25 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 482.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000327677; expected ratio = 0.0001obtained abs = 6.88803e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.181913; expected ratio = 0.001obtained abs = 78.9962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.867320e+05 Mflops = 389.66 -Solve time = 0.00 -Solve flops = 1.683000e+04 Mflops = 483.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00030065; expected ratio = 0.0001obtained abs = 6.32035e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.182188; expected ratio = 0.001obtained abs = 79.5145; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.867320e+05 Mflops = 389.08 -Solve time = 0.00 -Solve flops = 1.683000e+04 Mflops = 480.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000275749; expected ratio = 0.0001obtained abs = 5.79709e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.176348; expected ratio = 0.001obtained abs = 76.3823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.867320e+05 Mflops = 389.08 -Solve time = 0.00 -Solve flops = 1.683000e+04 Mflops = 480.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000252085; expected ratio = 0.0001obtained abs = 5.29995e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0994519; expected ratio = 0.001obtained abs = 43.0362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.867320e+05 Mflops = 389.85 -Solve time = 0.00 -Solve flops = 1.683000e+04 Mflops = 493.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000212375; expected ratio = 0.0001obtained abs = 4.46519e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0575278; expected ratio = 0.001obtained abs = 24.9616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.867320e+05 Mflops = 388.88 -Solve time = 0.00 -Solve flops = 1.683000e+04 Mflops = 483.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000167489; expected ratio = 0.0001obtained abs = 3.52164e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117852; expected ratio = 0.001obtained abs = 50.8572; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.864260e+05 Mflops = 388.44 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 479.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000149691; expected ratio = 0.0001obtained abs = 3.14753e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.114883; expected ratio = 0.001obtained abs = 49.762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.57841 - Final Residual ratio : 0.0023484 - Residual ratio : 0.000512929 - Slope : -0.147615 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.49057 - Final Residual ratio : 0.00198349 - Residual ratio : 0.000441702 - Slope : -0.14962 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.9426 - Final Residual ratio : 0.0042908 - Residual ratio : 0.000868127 - Slope : -0.16461 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.66479 - Final Residual ratio : 0.00239327 - Residual ratio : 0.00051305 - Slope : -0.1457 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.27697 - Final Residual ratio : 0.00224876 - Residual ratio : 0.000525784 - Slope : -0.147404 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.82795 - Final Residual ratio : 0.00312194 - Residual ratio : 0.000815563 - Slope : -0.131891 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.35988 - Final Residual ratio : 0.00248705 - Residual ratio : 0.000740221 - Slope : -0.124348 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.81949 - Final Residual ratio : 0.00206194 - Residual ratio : 0.000731315 - Slope : -0.0971528 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.46489 - Final Residual ratio : 0.00228379 - Residual ratio : 0.000926529 - Slope : -0.0912077 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.54456 - Final Residual ratio : 0.00205987 - Residual ratio : 0.000809516 - Slope : -0.0977886 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7351 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000477791 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.851830e+05 Mflops = 374.86 -Solve time = 0.00 -Solve flops = 1.677800e+04 Mflops = 478.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0274514; expected ratio = 0.0001obtained abs = 0.000590389; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.053809; expected ratio = 0.001obtained abs = 24.2183; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.830370e+05 Mflops = 375.04 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 475.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00603574; expected ratio = 0.0001obtained abs = 0.000129435; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0465463; expected ratio = 0.001obtained abs = 21.09; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.843930e+05 Mflops = 375.44 -Solve time = 0.00 -Solve flops = 1.673600e+04 Mflops = 480.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00257928; expected ratio = 0.0001obtained abs = 5.52942e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0438338; expected ratio = 0.001obtained abs = 19.9985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.836250e+05 Mflops = 374.05 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 489.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00146123; expected ratio = 0.0001obtained abs = 3.13191e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0392293; expected ratio = 0.001obtained abs = 17.8418; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.843930e+05 Mflops = 374.89 -Solve time = 0.00 -Solve flops = 1.673600e+04 Mflops = 477.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000808983; expected ratio = 0.0001obtained abs = 1.73383e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0379909; expected ratio = 0.001obtained abs = 17.3019; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.836250e+05 Mflops = 374.05 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 489.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000789743; expected ratio = 0.0001obtained abs = 1.69254e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.025458; expected ratio = 0.001obtained abs = 11.5615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.843930e+05 Mflops = 375.62 -Solve time = 0.00 -Solve flops = 1.673600e+04 Mflops = 490.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00063091; expected ratio = 0.0001obtained abs = 1.35221e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.024377; expected ratio = 0.001obtained abs = 11.0898; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.836250e+05 Mflops = 374.78 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 476.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000709149; expected ratio = 0.0001obtained abs = 1.51995e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0345671; expected ratio = 0.001obtained abs = 15.6612; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.843930e+05 Mflops = 374.71 -Solve time = 0.00 -Solve flops = 1.673600e+04 Mflops = 477.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000690636; expected ratio = 0.0001obtained abs = 1.48042e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0236197; expected ratio = 0.001obtained abs = 10.7112; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.836250e+05 Mflops = 374.78 -Solve time = 0.00 -Solve flops = 1.669600e+04 Mflops = 476.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000677794; expected ratio = 0.0001obtained abs = 1.45298e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0196563; expected ratio = 0.001obtained abs = 8.88386; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.843930e+05 Mflops = 375.62 -Solve time = 0.00 -Solve flops = 1.673600e+04 Mflops = 477.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000683261; expected ratio = 0.0001obtained abs = 1.46485e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0183917; expected ratio = 0.001obtained abs = 8.31768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.832650e+05 Mflops = 374.05 -Solve time = 0.00 -Solve flops = 1.667800e+04 Mflops = 489.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000664237; expected ratio = 0.0001obtained abs = 1.42415e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.025564; expected ratio = 0.001obtained abs = 11.5299; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833430e+05 Mflops = 374.03 -Solve time = 0.00 -Solve flops = 1.668600e+04 Mflops = 492.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000705004; expected ratio = 0.0001obtained abs = 1.51171e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0306456; expected ratio = 0.001obtained abs = 13.8213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.822150e+05 Mflops = 371.91 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 474.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000669379; expected ratio = 0.0001obtained abs = 1.4354e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0426277; expected ratio = 0.001obtained abs = 19.1907; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833430e+05 Mflops = 374.21 -Solve time = 0.00 -Solve flops = 1.668600e+04 Mflops = 489.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000752813; expected ratio = 0.0001obtained abs = 1.61447e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0612838; expected ratio = 0.001obtained abs = 27.5702; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.822150e+05 Mflops = 367.44 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 474.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000704888; expected ratio = 0.0001obtained abs = 1.51177e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0434279; expected ratio = 0.001obtained abs = 19.4922; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833430e+05 Mflops = 373.48 -Solve time = 0.00 -Solve flops = 1.668600e+04 Mflops = 489.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000759284; expected ratio = 0.0001obtained abs = 1.62857e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0243327; expected ratio = 0.001obtained abs = 10.9265; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.822150e+05 Mflops = 363.76 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 474.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00070044; expected ratio = 0.0001obtained abs = 1.5024e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0253091; expected ratio = 0.001obtained abs = 11.3404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.830370e+05 Mflops = 373.58 -Solve time = 0.00 -Solve flops = 1.666800e+04 Mflops = 475.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00075708; expected ratio = 0.0001obtained abs = 1.62401e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.016292; expected ratio = 0.001obtained abs = 7.30804; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.822150e+05 Mflops = 371.91 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 474.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00071786; expected ratio = 0.0001obtained abs = 1.5399e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.017064; expected ratio = 0.001obtained abs = 7.63342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.66895 - Final Residual ratio : 0.0025811 - Residual ratio : 0.000967086 - Slope : -0.0919438 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.62889 - Final Residual ratio : 0.00233604 - Residual ratio : 0.000888606 - Slope : -0.0905707 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.57139 - Final Residual ratio : 0.00615685 - Residual ratio : 0.000936916 - Slope : -0.262609 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.2933 - Final Residual ratio : 0.0202874 - Residual ratio : 0.000870953 - Slope : -1.45456 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.34296 - Final Residual ratio : 0.00479509 - Residual ratio : 0.00089746 - Slope : -0.190649 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.94433 - Final Residual ratio : 0.00408747 - Residual ratio : 0.000826699 - Slope : -0.176437 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.77243 - Final Residual ratio : 0.00396474 - Residual ratio : 0.00083076 - Slope : -0.158949 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.17595 - Final Residual ratio : 0.0040107 - Residual ratio : 0.000960428 - Slope : -0.245408 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.52342 - Final Residual ratio : 0.00339238 - Residual ratio : 0.000962808 - Slope : -0.135386 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12899 - Final Residual ratio : 0.00285328 - Residual ratio : 0.000911887 - Slope : -0.130256 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7451 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000477076 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.428310e+05 Mflops = 451.27 -Solve time = 0.00 -Solve flops = 1.870400e+04 Mflops = 506.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0270395; expected ratio = 0.0001obtained abs = 0.000591112; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0480774; expected ratio = 0.001obtained abs = 21.3706; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.405770e+05 Mflops = 448.67 -Solve time = 0.00 -Solve flops = 1.863200e+04 Mflops = 517.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00594729; expected ratio = 0.0001obtained abs = 0.000129831; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0238735; expected ratio = 0.001obtained abs = 10.6684; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.418310e+05 Mflops = 473.31 -Solve time = 0.00 -Solve flops = 1.865400e+04 Mflops = 547.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00114943; expected ratio = 0.0001obtained abs = 2.5092e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0274968; expected ratio = 0.001obtained abs = 12.3005; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.417230e+05 Mflops = 451.81 -Solve time = 0.00 -Solve flops = 1.864800e+04 Mflops = 517.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000645157; expected ratio = 0.0001obtained abs = 1.40833e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0274932; expected ratio = 0.001obtained abs = 12.2834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.417230e+05 Mflops = 452.62 -Solve time = 0.00 -Solve flops = 1.864800e+04 Mflops = 517.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000434476; expected ratio = 0.0001obtained abs = 9.48471e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0390074; expected ratio = 0.001obtained abs = 17.4074; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.418310e+05 Mflops = 452.01 -Solve time = 0.00 -Solve flops = 1.865400e+04 Mflops = 518.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000371013; expected ratio = 0.0001obtained abs = 8.09974e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0239371; expected ratio = 0.001obtained abs = 10.6601; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.418310e+05 Mflops = 451.21 -Solve time = 0.00 -Solve flops = 1.865400e+04 Mflops = 518.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000296283; expected ratio = 0.0001obtained abs = 6.46876e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00690815; expected ratio = 0.001obtained abs = 3.07471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.432530e+05 Mflops = 455.48 -Solve time = 0.00 -Solve flops = 1.872400e+04 Mflops = 520.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000263575; expected ratio = 0.0001obtained abs = 5.75503e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106206; expected ratio = 0.001obtained abs = 4.71469; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.432530e+05 Mflops = 455.48 -Solve time = 0.00 -Solve flops = 1.872400e+04 Mflops = 520.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000237162; expected ratio = 0.0001obtained abs = 5.17872e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0212058; expected ratio = 0.001obtained abs = 9.41428; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.432530e+05 Mflops = 454.67 -Solve time = 0.00 -Solve flops = 1.872400e+04 Mflops = 520.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000285288; expected ratio = 0.0001obtained abs = 6.23e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0412656; expected ratio = 0.001obtained abs = 18.2611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.432530e+05 Mflops = 454.67 -Solve time = 0.00 -Solve flops = 1.872400e+04 Mflops = 520.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000273998; expected ratio = 0.0001obtained abs = 5.98393e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0218677; expected ratio = 0.001obtained abs = 9.67535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.442530e+05 Mflops = 454.71 -Solve time = 0.00 -Solve flops = 1.877400e+04 Mflops = 521.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000225672; expected ratio = 0.0001obtained abs = 4.92876e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00855393; expected ratio = 0.001obtained abs = 3.77695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.442530e+05 Mflops = 455.73 -Solve time = 0.00 -Solve flops = 1.877400e+04 Mflops = 521.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000170127; expected ratio = 0.0001obtained abs = 3.71584e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00988271; expected ratio = 0.001obtained abs = 4.3645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.427770e+05 Mflops = 452.97 -Solve time = 0.00 -Solve flops = 1.874200e+04 Mflops = 520.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00019572; expected ratio = 0.0001obtained abs = 4.27499e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0128652; expected ratio = 0.001obtained abs = 5.67235; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.424710e+05 Mflops = 451.40 -Solve time = 0.00 -Solve flops = 1.872400e+04 Mflops = 520.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000163134; expected ratio = 0.0001obtained abs = 3.5634e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0245226; expected ratio = 0.001obtained abs = 10.819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.454930e+05 Mflops = 458.04 -Solve time = 0.00 -Solve flops = 1.883600e+04 Mflops = 523.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000268501; expected ratio = 0.0001obtained abs = 5.86516e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0546049; expected ratio = 0.001obtained abs = 24.0152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.441870e+05 Mflops = 454.59 -Solve time = 0.00 -Solve flops = 1.876800e+04 Mflops = 521.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000530376; expected ratio = 0.0001obtained abs = 1.15862e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0713501; expected ratio = 0.001obtained abs = 31.4125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.415370e+05 Mflops = 450.66 -Solve time = 0.00 -Solve flops = 1.868000e+04 Mflops = 518.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000307963; expected ratio = 0.0001obtained abs = 6.72773e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0431151; expected ratio = 0.001obtained abs = 18.9459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.415370e+05 Mflops = 450.46 -Solve time = 0.00 -Solve flops = 1.868000e+04 Mflops = 505.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00024154; expected ratio = 0.0001obtained abs = 5.27678e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0202424; expected ratio = 0.001obtained abs = 8.89877; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.442530e+05 Mflops = 454.92 -Solve time = 0.00 -Solve flops = 1.877400e+04 Mflops = 521.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000174809; expected ratio = 0.0001obtained abs = 3.81901e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0175052; expected ratio = 0.001obtained abs = 7.68771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.81531 - Final Residual ratio : 0.0037758 - Residual ratio : 0.000989644 - Slope : -0.131432 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.66158 - Final Residual ratio : 0.00465337 - Residual ratio : 0.000998239 - Slope : -0.166319 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.23336 - Final Residual ratio : 0.00415429 - Residual ratio : 0.00079381 - Slope : -0.186757 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.90497 - Final Residual ratio : 0.00487057 - Residual ratio : 0.000992988 - Slope : -0.175003 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.40377 - Final Residual ratio : 0.00357397 - Residual ratio : 0.000811571 - Slope : -0.151731 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.80059 - Final Residual ratio : 0.00295659 - Residual ratio : 0.00077793 - Slope : -0.146063 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36015 - Final Residual ratio : 0.00295611 - Residual ratio : 0.000879756 - Slope : -0.115765 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.96511 - Final Residual ratio : 0.00225001 - Residual ratio : 0.000758829 - Slope : -0.095576 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.59351 - Final Residual ratio : 0.00242403 - Residual ratio : 0.000934652 - Slope : -0.0959661 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.41898 - Final Residual ratio : 0.00221795 - Residual ratio : 0.000916896 - Slope : -0.100698 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7551 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000487089 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.493030e+05 Mflops = 438.98 -Solve time = 0.00 -Solve flops = 1.881400e+04 Mflops = 496.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0251325; expected ratio = 0.0001obtained abs = 0.000559174; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0359458; expected ratio = 0.001obtained abs = 16.0846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000476837 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.488410e+05 Mflops = 447.56 -Solve time = 0.00 -Solve flops = 1.879200e+04 Mflops = 521.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00488447; expected ratio = 0.0001obtained abs = 0.000108438; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.042865; expected ratio = 0.001obtained abs = 19.2713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.498410e+05 Mflops = 449.36 -Solve time = 0.00 -Solve flops = 1.884200e+04 Mflops = 509.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00202451; expected ratio = 0.0001obtained abs = 4.49411e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0346756; expected ratio = 0.001obtained abs = 15.6515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.498410e+05 Mflops = 449.36 -Solve time = 0.00 -Solve flops = 1.884200e+04 Mflops = 506.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000845202; expected ratio = 0.0001obtained abs = 1.87609e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0350249; expected ratio = 0.001obtained abs = 15.7436; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.500810e+05 Mflops = 449.79 -Solve time = 0.00 -Solve flops = 1.885400e+04 Mflops = 523.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000462376; expected ratio = 0.0001obtained abs = 1.02638e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0277086; expected ratio = 0.001obtained abs = 12.4642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 451.59 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 508.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000359899; expected ratio = 0.0001obtained abs = 7.98978e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0249637; expected ratio = 0.001obtained abs = 11.1885; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 450.82 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 525.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000382889; expected ratio = 0.0001obtained abs = 8.50118e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0394666; expected ratio = 0.001obtained abs = 17.6867; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 446.04 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 511.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000351569; expected ratio = 0.0001obtained abs = 7.80678e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0341659; expected ratio = 0.001obtained abs = 15.2321; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478983 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 451.59 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 525.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000343411; expected ratio = 0.0001obtained abs = 7.62663e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0378146; expected ratio = 0.001obtained abs = 16.8856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.507750e+05 Mflops = 451.04 -Solve time = 0.00 -Solve flops = 1.888600e+04 Mflops = 524.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000296466; expected ratio = 0.0001obtained abs = 6.58484e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0526498; expected ratio = 0.001obtained abs = 23.364; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 450.62 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 511.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000276399; expected ratio = 0.0001obtained abs = 6.13985e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0483196; expected ratio = 0.001obtained abs = 21.4778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 451.59 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 525.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000281833; expected ratio = 0.0001obtained abs = 6.26121e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0597899; expected ratio = 0.001obtained abs = 26.4217; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 451.59 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 508.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000263643; expected ratio = 0.0001obtained abs = 5.85769e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0541967; expected ratio = 0.001obtained abs = 24.0044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 450.62 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 525.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000255752; expected ratio = 0.0001obtained abs = 5.68285e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0675675; expected ratio = 0.001obtained abs = 29.7515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 450.05 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 525.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000515168; expected ratio = 0.0001obtained abs = 1.1448e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0544144; expected ratio = 0.001obtained abs = 24.0397; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.507750e+05 Mflops = 450.27 -Solve time = 0.00 -Solve flops = 1.888600e+04 Mflops = 524.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000646916; expected ratio = 0.0001obtained abs = 1.4376e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0257956; expected ratio = 0.001obtained abs = 11.3535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 450.82 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 511.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000488739; expected ratio = 0.0001obtained abs = 1.08619e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0502209; expected ratio = 0.001obtained abs = 22.1729; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.510810e+05 Mflops = 450.82 -Solve time = 0.00 -Solve flops = 1.890400e+04 Mflops = 525.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000352339; expected ratio = 0.0001obtained abs = 7.83093e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0729898; expected ratio = 0.001obtained abs = 31.9726; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.507750e+05 Mflops = 449.31 -Solve time = 0.00 -Solve flops = 1.888600e+04 Mflops = 524.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000561502; expected ratio = 0.0001obtained abs = 1.24808e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0445104; expected ratio = 0.001obtained abs = 19.5561; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 2.500810e+05 Mflops = 449.79 -Solve time = 0.00 -Solve flops = 1.885400e+04 Mflops = 510.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000311514; expected ratio = 0.0001obtained abs = 6.92445e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.013453; expected ratio = 0.001obtained abs = 5.90012; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.2225 - Final Residual ratio : 0.00144202 - Residual ratio : 0.00064883 - Slope : -0.0765881 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.17767 - Final Residual ratio : 0.00196582 - Residual ratio : 0.000902714 - Slope : -0.0750244 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08751 - Final Residual ratio : 0.00132679 - Residual ratio : 0.000635588 - Slope : -0.0672961 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.91895 - Final Residual ratio : 0.00167267 - Residual ratio : 0.000871656 - Slope : -0.095864 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8333 - Final Residual ratio : 0.00171987 - Residual ratio : 0.000938124 - Slope : -0.0654137 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.68361 - Final Residual ratio : 0.00146535 - Residual ratio : 0.000870361 - Slope : -0.0672859 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67218 - Final Residual ratio : 0.00129064 - Residual ratio : 0.000771829 - Slope : -0.0618849 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63617 - Final Residual ratio : 0.00140676 - Residual ratio : 0.000859789 - Slope : -0.0563712 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53041 - Final Residual ratio : 0.00129473 - Residual ratio : 0.000846004 - Slope : -0.0546113 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49579 - Final Residual ratio : 0.00118079 - Residual ratio : 0.000789411 - Slope : -0.057485 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 199 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7651 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.477220e+05 Mflops = 445.55 -Solve time = 0.00 -Solve flops = 1.874000e+04 Mflops = 520.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.023707; expected ratio = 0.0001obtained abs = 0.000535772; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0500932; expected ratio = 0.001obtained abs = 21.9981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453234 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.471840e+05 Mflops = 446.11 -Solve time = 0.00 -Solve flops = 1.871200e+04 Mflops = 506.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00383105; expected ratio = 0.0001obtained abs = 8.64284e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0415863; expected ratio = 0.001obtained abs = 18.3859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.489620e+05 Mflops = 447.78 -Solve time = 0.00 -Solve flops = 1.880200e+04 Mflops = 522.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0016414; expected ratio = 0.0001obtained abs = 3.70195e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0402788; expected ratio = 0.001obtained abs = 17.9204; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.477220e+05 Mflops = 438.41 -Solve time = 0.00 -Solve flops = 1.874000e+04 Mflops = 507.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00070597; expected ratio = 0.0001obtained abs = 1.59191e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.033125; expected ratio = 0.001obtained abs = 14.7113; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.478540e+05 Mflops = 446.55 -Solve time = 0.00 -Solve flops = 1.874600e+04 Mflops = 520.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000430102; expected ratio = 0.0001obtained abs = 9.69771e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0266292; expected ratio = 0.001obtained abs = 11.8684; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.489620e+05 Mflops = 448.55 -Solve time = 0.00 -Solve flops = 1.880200e+04 Mflops = 522.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000295584; expected ratio = 0.0001obtained abs = 6.66447e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0240523; expected ratio = 0.001obtained abs = 10.695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.508820e+05 Mflops = 452.20 -Solve time = 0.00 -Solve flops = 1.884800e+04 Mflops = 523.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000220252; expected ratio = 0.0001obtained abs = 4.96597e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0338402; expected ratio = 0.001obtained abs = 15.088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.509900e+05 Mflops = 452.98 -Solve time = 0.00 -Solve flops = 1.885400e+04 Mflops = 510.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000295965; expected ratio = 0.0001obtained abs = 6.67315e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0498482; expected ratio = 0.001obtained abs = 22.148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.509900e+05 Mflops = 452.40 -Solve time = 0.00 -Solve flops = 1.885400e+04 Mflops = 523.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000307179; expected ratio = 0.0001obtained abs = 6.9262e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0313124; expected ratio = 0.001obtained abs = 13.9147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.509900e+05 Mflops = 452.98 -Solve time = 0.00 -Solve flops = 1.885400e+04 Mflops = 523.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000331588; expected ratio = 0.0001obtained abs = 7.47681e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0336215; expected ratio = 0.001obtained abs = 14.9515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.489620e+05 Mflops = 447.78 -Solve time = 0.00 -Solve flops = 1.880200e+04 Mflops = 522.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000252699; expected ratio = 0.0001obtained abs = 5.69809e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0404665; expected ratio = 0.001obtained abs = 17.9543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.489620e+05 Mflops = 448.55 -Solve time = 0.00 -Solve flops = 1.880200e+04 Mflops = 522.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000195392; expected ratio = 0.0001obtained abs = 4.40599e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0371836; expected ratio = 0.001obtained abs = 16.5151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.488540e+05 Mflops = 446.82 -Solve time = 0.00 -Solve flops = 1.879600e+04 Mflops = 522.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000142379; expected ratio = 0.0001obtained abs = 3.21066e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0328326; expected ratio = 0.001obtained abs = 14.5641; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.489620e+05 Mflops = 447.01 -Solve time = 0.00 -Solve flops = 1.880200e+04 Mflops = 522.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000158917; expected ratio = 0.0001obtained abs = 3.58365e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0350052; expected ratio = 0.001obtained abs = 15.5326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.508820e+05 Mflops = 453.76 -Solve time = 0.00 -Solve flops = 1.884800e+04 Mflops = 523.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000137762; expected ratio = 0.0001obtained abs = 3.10667e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0402005; expected ratio = 0.001obtained abs = 17.8293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.489620e+05 Mflops = 448.55 -Solve time = 0.00 -Solve flops = 1.880200e+04 Mflops = 522.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000148398; expected ratio = 0.0001obtained abs = 3.3466e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0441228; expected ratio = 0.001obtained abs = 19.5774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.509900e+05 Mflops = 452.20 -Solve time = 0.00 -Solve flops = 1.885400e+04 Mflops = 523.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000210207; expected ratio = 0.0001obtained abs = 4.74061e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0541514; expected ratio = 0.001obtained abs = 23.9776; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.489620e+05 Mflops = 447.78 -Solve time = 0.00 -Solve flops = 1.880200e+04 Mflops = 522.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000224085; expected ratio = 0.0001obtained abs = 5.05371e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0426573; expected ratio = 0.001obtained abs = 18.9089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.489620e+05 Mflops = 448.55 -Solve time = 0.00 -Solve flops = 1.880200e+04 Mflops = 522.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000158798; expected ratio = 0.0001obtained abs = 3.58137e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0371395; expected ratio = 0.001obtained abs = 16.4257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.489620e+05 Mflops = 447.78 -Solve time = 0.00 -Solve flops = 1.880200e+04 Mflops = 522.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000111541; expected ratio = 0.0001obtained abs = 2.51561e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0377894; expected ratio = 0.001obtained abs = 16.7468; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40194 - Final Residual ratio : 0.000916209 - Residual ratio : 0.000653529 - Slope : -0.058376 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.44075 - Final Residual ratio : 0.00114162 - Residual ratio : 0.000792377 - Slope : -0.0496418 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.45642 - Final Residual ratio : 0.00117504 - Residual ratio : 0.000806801 - Slope : -0.048508 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.3949 - Final Residual ratio : 0.00112603 - Residual ratio : 0.000807251 - Slope : -0.0480611 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36152 - Final Residual ratio : 0.000989835 - Residual ratio : 0.00072701 - Slope : -0.0469147 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22902 - Final Residual ratio : 0.00101454 - Residual ratio : 0.000825482 - Slope : -0.0491203 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.23009 - Final Residual ratio : 0.000877457 - Residual ratio : 0.000713328 - Slope : -0.0472773 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24645 - Final Residual ratio : 0.000994946 - Residual ratio : 0.000798223 - Slope : -0.0429468 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21949 - Final Residual ratio : 0.00107623 - Residual ratio : 0.000882529 - Slope : -0.0435146 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22863 - Final Residual ratio : 0.00117879 - Residual ratio : 0.000959437 - Slope : -0.0472097 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 199 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7751 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.792960e+05 Mflops = 446.10 -Solve time = 0.00 -Solve flops = 1.999800e+04 Mflops = 524.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0225835; expected ratio = 0.0001obtained abs = 0.00051564; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0439132; expected ratio = 0.001obtained abs = 19.9264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.789990e+05 Mflops = 451.47 -Solve time = 0.00 -Solve flops = 1.996200e+04 Mflops = 523.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00244753; expected ratio = 0.0001obtained abs = 5.57974e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.070076; expected ratio = 0.001obtained abs = 31.8622; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.885750e+05 Mflops = 453.66 -Solve time = 0.00 -Solve flops = 2.025600e+04 Mflops = 534.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00167705; expected ratio = 0.0001obtained abs = 3.82231e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.046221; expected ratio = 0.001obtained abs = 21.1695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.864570e+05 Mflops = 451.86 -Solve time = 0.00 -Solve flops = 2.019600e+04 Mflops = 532.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000749178; expected ratio = 0.0001obtained abs = 1.70726e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0686302; expected ratio = 0.001obtained abs = 31.275; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.869070e+05 Mflops = 451.21 -Solve time = 0.00 -Solve flops = 2.020800e+04 Mflops = 529.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000611313; expected ratio = 0.0001obtained abs = 1.39307e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0582534; expected ratio = 0.001obtained abs = 26.6472; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.872430e+05 Mflops = 446.88 -Solve time = 0.00 -Solve flops = 2.022000e+04 Mflops = 530.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000356907; expected ratio = 0.0001obtained abs = 8.13334e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0107205; expected ratio = 0.001obtained abs = 4.89837; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.872430e+05 Mflops = 452.25 -Solve time = 0.00 -Solve flops = 2.022000e+04 Mflops = 533.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000194464; expected ratio = 0.0001obtained abs = 4.43159e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0151626; expected ratio = 0.001obtained abs = 6.92982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.866010e+05 Mflops = 452.77 -Solve time = 0.00 -Solve flops = 2.020200e+04 Mflops = 532.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000192697; expected ratio = 0.0001obtained abs = 4.39142e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00924462; expected ratio = 0.001obtained abs = 4.22149; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.872430e+05 Mflops = 452.25 -Solve time = 0.00 -Solve flops = 2.022000e+04 Mflops = 533.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000169251; expected ratio = 0.0001obtained abs = 3.85725e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0124719; expected ratio = 0.001obtained abs = 5.69103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.872430e+05 Mflops = 451.74 -Solve time = 0.00 -Solve flops = 2.022000e+04 Mflops = 530.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000231014; expected ratio = 0.0001obtained abs = 5.26495e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0150226; expected ratio = 0.001obtained abs = 6.8494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.884310e+05 Mflops = 454.12 -Solve time = 0.00 -Solve flops = 2.025000e+04 Mflops = 547.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000242793; expected ratio = 0.0001obtained abs = 5.53368e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0294527; expected ratio = 0.001obtained abs = 13.4191; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.884310e+05 Mflops = 444.44 -Solve time = 0.00 -Solve flops = 2.025000e+04 Mflops = 530.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000382737; expected ratio = 0.0001obtained abs = 8.72349e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0365836; expected ratio = 0.001obtained abs = 16.6432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.885750e+05 Mflops = 453.83 -Solve time = 0.00 -Solve flops = 2.025600e+04 Mflops = 531.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000488617; expected ratio = 0.0001obtained abs = 1.11374e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.034918; expected ratio = 0.001obtained abs = 15.9298; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.885750e+05 Mflops = 452.98 -Solve time = 0.00 -Solve flops = 2.025600e+04 Mflops = 548.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000399582; expected ratio = 0.0001obtained abs = 9.10795e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0640789; expected ratio = 0.001obtained abs = 29.0904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.880950e+05 Mflops = 452.91 -Solve time = 0.00 -Solve flops = 2.023800e+04 Mflops = 533.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000286181; expected ratio = 0.0001obtained abs = 6.5234e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0586663; expected ratio = 0.001obtained abs = 26.7345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.884310e+05 Mflops = 453.44 -Solve time = 0.00 -Solve flops = 2.025000e+04 Mflops = 534.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000288135; expected ratio = 0.0001obtained abs = 6.56794e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0932023; expected ratio = 0.001obtained abs = 42.2811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.880950e+05 Mflops = 452.23 -Solve time = 0.00 -Solve flops = 2.023800e+04 Mflops = 530.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00143509; expected ratio = 0.0001obtained abs = 3.27129e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0839033; expected ratio = 0.001obtained abs = 38.1427; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.885750e+05 Mflops = 452.98 -Solve time = 0.00 -Solve flops = 2.025600e+04 Mflops = 548.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00177745; expected ratio = 0.0001obtained abs = 4.05245e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0314389; expected ratio = 0.001obtained abs = 14.248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.885750e+05 Mflops = 453.66 -Solve time = 0.00 -Solve flops = 2.025600e+04 Mflops = 548.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00079301; expected ratio = 0.0001obtained abs = 1.8079e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0378029; expected ratio = 0.001obtained abs = 17.2204; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.884310e+05 Mflops = 454.29 -Solve time = 0.00 -Solve flops = 2.025000e+04 Mflops = 534.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000337118; expected ratio = 0.0001obtained abs = 7.6853e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0435132; expected ratio = 0.001obtained abs = 19.7138; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11231 - Final Residual ratio : 0.00235155 - Residual ratio : 0.000755562 - Slope : -0.129582 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.068 - Final Residual ratio : 0.00342056 - Residual ratio : 0.000840846 - Slope : -0.145163 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.73717 - Final Residual ratio : 0.00294483 - Residual ratio : 0.000621642 - Slope : -0.163249 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.72646 - Final Residual ratio : 0.0047221 - Residual ratio : 0.000999076 - Slope : -0.168634 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.34213 - Final Residual ratio : 0.00339692 - Residual ratio : 0.000782317 - Slope : -0.154955 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.77327 - Final Residual ratio : 0.00326688 - Residual ratio : 0.000865795 - Slope : -0.145 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.30175 - Final Residual ratio : 0.00217854 - Residual ratio : 0.000659813 - Slope : -0.117842 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.96243 - Final Residual ratio : 0.00207587 - Residual ratio : 0.00070073 - Slope : -0.102081 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.70939 - Final Residual ratio : 0.00250524 - Residual ratio : 0.00092465 - Slope : -0.0933408 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.52036 - Final Residual ratio : 0.00245542 - Residual ratio : 0.000974236 - Slope : -0.0868242 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 199 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7851 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.977200e+05 Mflops = 373.05 -Solve time = 0.00 -Solve flops = 1.733600e+04 Mflops = 469.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0231845; expected ratio = 0.0001obtained abs = 0.000533269; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0609587; expected ratio = 0.001obtained abs = 27.3357; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.974800e+05 Mflops = 380.47 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 481.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00525479; expected ratio = 0.0001obtained abs = 0.000120841; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0452968; expected ratio = 0.001obtained abs = 20.3115; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986000e+05 Mflops = 381.06 -Solve time = 0.00 -Solve flops = 1.738000e+04 Mflops = 495.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000951974; expected ratio = 0.0001obtained abs = 2.18911e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0261294; expected ratio = 0.001obtained abs = 11.7491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986000e+05 Mflops = 380.36 -Solve time = 0.00 -Solve flops = 1.738000e+04 Mflops = 482.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000434147; expected ratio = 0.0001obtained abs = 9.98375e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0179279; expected ratio = 0.001obtained abs = 8.03789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986000e+05 Mflops = 381.23 -Solve time = 0.00 -Solve flops = 1.738000e+04 Mflops = 482.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00029517; expected ratio = 0.0001obtained abs = 6.78815e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.013185; expected ratio = 0.001obtained abs = 5.91506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986000e+05 Mflops = 381.06 -Solve time = 0.00 -Solve flops = 1.738000e+04 Mflops = 482.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000319234; expected ratio = 0.0001obtained abs = 7.34196e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0229853; expected ratio = 0.001obtained abs = 10.2823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986000e+05 Mflops = 372.54 -Solve time = 0.00 -Solve flops = 1.738000e+04 Mflops = 495.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000318581; expected ratio = 0.0001obtained abs = 7.32733e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.023367; expected ratio = 0.001obtained abs = 10.4642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 376.30 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 483.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000243393; expected ratio = 0.0001obtained abs = 5.59826e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.028684; expected ratio = 0.001obtained abs = 12.8068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 382.15 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 483.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000202221; expected ratio = 0.0001obtained abs = 4.65145e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0350107; expected ratio = 0.001obtained abs = 15.6603; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 382.85 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 510.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000232981; expected ratio = 0.0001obtained abs = 5.35925e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0696265; expected ratio = 0.001obtained abs = 31.0261; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.000800e+05 Mflops = 384.78 -Solve time = 0.00 -Solve flops = 1.745400e+04 Mflops = 484.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00336665; expected ratio = 0.0001obtained abs = 7.74432e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0720911; expected ratio = 0.001obtained abs = 32.1381; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.979600e+05 Mflops = 382.28 -Solve time = 0.00 -Solve flops = 1.734800e+04 Mflops = 494.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00270174; expected ratio = 0.0001obtained abs = 6.2161e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.029339; expected ratio = 0.001obtained abs = 13.1049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.973200e+05 Mflops = 380.17 -Solve time = 0.00 -Solve flops = 1.731600e+04 Mflops = 494.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000742368; expected ratio = 0.0001obtained abs = 1.70794e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0267775; expected ratio = 0.001obtained abs = 11.9237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 373.44 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 483.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000336049; expected ratio = 0.0001obtained abs = 7.73143e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0135568; expected ratio = 0.001obtained abs = 6.04496; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 382.15 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 483.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000178731; expected ratio = 0.0001obtained abs = 4.11203e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.011992; expected ratio = 0.001obtained abs = 5.34017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 382.15 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 483.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000104103; expected ratio = 0.0001obtained abs = 2.39509e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00986078; expected ratio = 0.001obtained abs = 4.39421; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 381.98 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 483.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000145179; expected ratio = 0.0001obtained abs = 3.34013e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0188839; expected ratio = 0.001obtained abs = 8.40474; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 382.15 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 496.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000200645; expected ratio = 0.0001obtained abs = 4.61623e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0268013; expected ratio = 0.001obtained abs = 11.9484; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 382.85 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 483.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000185939; expected ratio = 0.0001obtained abs = 4.2779e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0788801; expected ratio = 0.001obtained abs = 35.0666; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990800e+05 Mflops = 381.45 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 496.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00123101; expected ratio = 0.0001obtained abs = 2.83217e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0757163; expected ratio = 0.001obtained abs = 33.7119; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7861 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.74647 - Final Residual ratio : 0.00268984 - Residual ratio : 0.000717966 - Slope : -0.133707 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.47993 - Final Residual ratio : 0.00371945 - Residual ratio : 0.000573995 - Slope : -0.223318 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.29679 - Final Residual ratio : 0.00528348 - Residual ratio : 0.000724082 - Slope : -0.251431 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 82.4087 - Final Residual ratio : 0.0811369 - Residual ratio : 0.000984567 - Slope : -4.11638 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.8863 - Final Residual ratio : 0.0302573 - Residual ratio : 0.000979636 - Slope : -1.18677 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.4449 - Final Residual ratio : 0.0146138 - Residual ratio : 0.000946192 - Slope : -0.593471 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8323 - Final Residual ratio : 0.01224 - Residual ratio : 0.000953845 - Slope : -0.457858 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4496 - Final Residual ratio : 0.00495389 - Residual ratio : 0.000474073 - Slope : -0.401718 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1352 - Final Residual ratio : 0.00904211 - Residual ratio : 0.000892148 - Slope : -0.349178 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.73674 - Final Residual ratio : 0.00543727 - Residual ratio : 0.000622346 - Slope : -0.281655 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.7951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 199 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.7951 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.863760e+05 Mflops = 374.92 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 480.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0204445; expected ratio = 0.0001obtained abs = 0.000474485; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0432597; expected ratio = 0.001obtained abs = 19.5324; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.866160e+05 Mflops = 376.31 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 481.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0037789; expected ratio = 0.0001obtained abs = 8.75363e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0605048; expected ratio = 0.001obtained abs = 27.5142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.866160e+05 Mflops = 373.97 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 481.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00264126; expected ratio = 0.0001obtained abs = 6.11483e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0376967; expected ratio = 0.001obtained abs = 17.3264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.866160e+05 Mflops = 375.59 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 481.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00114217; expected ratio = 0.0001obtained abs = 2.6432e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0362507; expected ratio = 0.001obtained abs = 16.6564; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.855720e+05 Mflops = 373.49 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 479.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000764358; expected ratio = 0.0001obtained abs = 1.76846e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0254072; expected ratio = 0.001obtained abs = 11.7408; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.855720e+05 Mflops = 373.49 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 479.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000446798; expected ratio = 0.0001obtained abs = 1.03355e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0109204; expected ratio = 0.001obtained abs = 5.04948; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.852660e+05 Mflops = 373.59 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000416404; expected ratio = 0.0001obtained abs = 9.63141e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00995992; expected ratio = 0.001obtained abs = 4.61747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.855720e+05 Mflops = 373.49 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 479.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000296929; expected ratio = 0.0001obtained abs = 6.8672e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118193; expected ratio = 0.001obtained abs = 5.48098; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.852660e+05 Mflops = 373.59 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000423006; expected ratio = 0.0001obtained abs = 9.78255e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0114666; expected ratio = 0.001obtained abs = 5.3253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.852660e+05 Mflops = 363.96 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 466.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000238217; expected ratio = 0.0001obtained abs = 5.50861e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0147972; expected ratio = 0.001obtained abs = 6.88194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.852660e+05 Mflops = 373.59 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000285999; expected ratio = 0.0001obtained abs = 6.61326e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0254596; expected ratio = 0.001obtained abs = 11.8372; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.852660e+05 Mflops = 368.98 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000250474; expected ratio = 0.0001obtained abs = 5.79138e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0361988; expected ratio = 0.001obtained abs = 16.8845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.852660e+05 Mflops = 373.59 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000292573; expected ratio = 0.0001obtained abs = 6.76454e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0338254; expected ratio = 0.001obtained abs = 15.75; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.843860e+05 Mflops = 372.53 -Solve time = 0.00 -Solve flops = 1.676000e+04 Mflops = 478.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000225688; expected ratio = 0.0001obtained abs = 5.21775e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0250969; expected ratio = 0.001obtained abs = 11.7156; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.850580e+05 Mflops = 373.17 -Solve time = 0.00 -Solve flops = 1.679200e+04 Mflops = 479.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000250463; expected ratio = 0.0001obtained abs = 5.79036e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0090566; expected ratio = 0.001obtained abs = 4.23049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.852660e+05 Mflops = 373.41 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000209336; expected ratio = 0.0001obtained abs = 4.83921e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00776006; expected ratio = 0.001obtained abs = 3.62823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.859380e+05 Mflops = 374.76 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 480.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000319081; expected ratio = 0.0001obtained abs = 7.37602e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0169568; expected ratio = 0.001obtained abs = 7.92637; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.843860e+05 Mflops = 371.81 -Solve time = 0.00 -Solve flops = 1.676000e+04 Mflops = 478.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000285195; expected ratio = 0.0001obtained abs = 6.59225e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0212613; expected ratio = 0.001obtained abs = 9.95659; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.850580e+05 Mflops = 373.17 -Solve time = 0.00 -Solve flops = 1.679200e+04 Mflops = 429.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000254051; expected ratio = 0.0001obtained abs = 5.87229e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0108392; expected ratio = 0.001obtained abs = 5.07684; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.852660e+05 Mflops = 371.98 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 482.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000177374; expected ratio = 0.0001obtained abs = 4.09971e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0107058; expected ratio = 0.001obtained abs = 5.02135; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.7961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.86382 - Final Residual ratio : 0.00689107 - Residual ratio : 0.000876301 - Slope : -0.261898 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.76628 - Final Residual ratio : 0.00485071 - Residual ratio : 0.000716895 - Slope : -0.260055 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.55884 - Final Residual ratio : 0.0048336 - Residual ratio : 0.000869535 - Slope : -0.205704 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.7991 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.45552 - Final Residual ratio : 0.00364431 - Residual ratio : 0.00081793 - Slope : -0.171226 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.7991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.7477 - Final Residual ratio : 0.00267699 - Residual ratio : 0.000714302 - Slope : -0.124834 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.15875 - Final Residual ratio : 0.00300555 - Residual ratio : 0.0009515 - Slope : -0.105191 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.89054 - Final Residual ratio : 0.00254592 - Residual ratio : 0.000880774 - Slope : -0.11552 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.73722 - Final Residual ratio : 0.0019281 - Residual ratio : 0.0007044 - Slope : -0.0882351 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.59641 - Final Residual ratio : 0.0010795 - Residual ratio : 0.000415765 - Slope : -0.0682981 - Tolerance : 0.001 - Number of iterations : 38 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.41321 - Final Residual ratio : 0.00168739 - Residual ratio : 0.000699229 - Slope : -0.0927509 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 199 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8051 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.969250e+05 Mflops = 368.73 -Solve time = 0.00 -Solve flops = 1.723200e+04 Mflops = 478.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0231752; expected ratio = 0.0001obtained abs = 0.000535913; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0634803; expected ratio = 0.001obtained abs = 28.7315; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.984430e+05 Mflops = 382.33 -Solve time = 0.00 -Solve flops = 1.731200e+04 Mflops = 493.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0107479; expected ratio = 0.0001obtained abs = 0.000249132; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0492893; expected ratio = 0.001obtained abs = 22.0509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.993230e+05 Mflops = 383.32 -Solve time = 0.00 -Solve flops = 1.735600e+04 Mflops = 495.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00207781; expected ratio = 0.0001obtained abs = 4.81777e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.032793; expected ratio = 0.001obtained abs = 14.623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.977710e+05 Mflops = 381.21 -Solve time = 0.00 -Solve flops = 1.728000e+04 Mflops = 510.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00114738; expected ratio = 0.0001obtained abs = 2.66123e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0233129; expected ratio = 0.001obtained abs = 10.3361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.977710e+05 Mflops = 381.91 -Solve time = 0.00 -Solve flops = 1.728000e+04 Mflops = 493.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00062055; expected ratio = 0.0001obtained abs = 1.43954e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0200907; expected ratio = 0.001obtained abs = 8.90622; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 383.43 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 494.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000343531; expected ratio = 0.0001obtained abs = 7.96975e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0319929; expected ratio = 0.001obtained abs = 14.1345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 383.61 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 494.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000321174; expected ratio = 0.0001obtained abs = 7.45136e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0298454; expected ratio = 0.001obtained abs = 13.2079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 377.70 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 494.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000204062; expected ratio = 0.0001obtained abs = 4.73443e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0133719; expected ratio = 0.001obtained abs = 5.91098; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.000370e+05 Mflops = 379.65 -Solve time = 0.00 -Solve flops = 1.736600e+04 Mflops = 495.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000139234; expected ratio = 0.0001obtained abs = 3.23035e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0144675; expected ratio = 0.001obtained abs = 6.40356; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.000370e+05 Mflops = 379.65 -Solve time = 0.00 -Solve flops = 1.736600e+04 Mflops = 495.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000120448; expected ratio = 0.0001obtained abs = 2.79449e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0145523; expected ratio = 0.001obtained abs = 6.43505; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 382.73 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 508.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000120343; expected ratio = 0.0001obtained abs = 2.79202e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.019929; expected ratio = 0.001obtained abs = 8.82783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 382.03 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 494.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000152384; expected ratio = 0.0001obtained abs = 3.53541e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.041851; expected ratio = 0.001obtained abs = 18.4901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.989570e+05 Mflops = 382.62 -Solve time = 0.00 -Solve flops = 1.734200e+04 Mflops = 494.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00025783; expected ratio = 0.0001obtained abs = 5.98187e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0516725; expected ratio = 0.001obtained abs = 22.9153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453234 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 382.73 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 494.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000254916; expected ratio = 0.0001obtained abs = 5.91414e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0476296; expected ratio = 0.001obtained abs = 21.0463; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.977710e+05 Mflops = 381.91 -Solve time = 0.00 -Solve flops = 1.728000e+04 Mflops = 506.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000261312; expected ratio = 0.0001obtained abs = 6.06264e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0372256; expected ratio = 0.001obtained abs = 16.4945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 382.73 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 494.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000183241; expected ratio = 0.0001obtained abs = 4.25131e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0375565; expected ratio = 0.001obtained abs = 16.5992; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 384.32 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 494.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000233252; expected ratio = 0.0001obtained abs = 5.41154e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0310442; expected ratio = 0.001obtained abs = 13.7506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 383.43 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 511.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000164587; expected ratio = 0.0001obtained abs = 3.81848e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0145598; expected ratio = 0.001obtained abs = 6.44286; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.000370e+05 Mflops = 378.79 -Solve time = 0.00 -Solve flops = 1.736600e+04 Mflops = 495.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000124414; expected ratio = 0.0001obtained abs = 2.88642e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0139091; expected ratio = 0.001obtained abs = 6.16216; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.986510e+05 Mflops = 373.30 -Solve time = 0.00 -Solve flops = 1.732400e+04 Mflops = 494.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000126085; expected ratio = 0.0001obtained abs = 2.92519e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018014; expected ratio = 0.001obtained abs = 7.97043; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.50752 - Final Residual ratio : 0.00211373 - Residual ratio : 0.000842954 - Slope : -0.092793 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.21538 - Final Residual ratio : 0.00287757 - Residual ratio : 0.000894939 - Slope : -0.123558 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.40128 - Final Residual ratio : 0.00319912 - Residual ratio : 0.000940564 - Slope : -0.125855 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.30592 - Final Residual ratio : 0.00264082 - Residual ratio : 0.000798814 - Slope : -0.117974 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.14313 - Final Residual ratio : 0.00240902 - Residual ratio : 0.000766439 - Slope : -0.108301 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8111 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.74642 - Final Residual ratio : 0.00211655 - Residual ratio : 0.000770657 - Slope : -0.10555 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.46033 - Final Residual ratio : 0.00202061 - Residual ratio : 0.000821278 - Slope : -0.0910483 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.24768 - Final Residual ratio : 0.00218323 - Residual ratio : 0.000971326 - Slope : -0.0801964 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.09157 - Final Residual ratio : 0.00160318 - Residual ratio : 0.000766497 - Slope : -0.0720678 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08272 - Final Residual ratio : 0.00120764 - Residual ratio : 0.000579835 - Slope : -0.0717764 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 200 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8151 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000480175 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.984470e+05 Mflops = 380.24 -Solve time = 0.00 -Solve flops = 1.730800e+04 Mflops = 368.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0198005; expected ratio = 0.0001obtained abs = 0.000461452; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.229448; expected ratio = 0.001obtained abs = 106.002; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.987110e+05 Mflops = 376.28 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 496.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.01145; expected ratio = 0.0001obtained abs = 0.000266563; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19595; expected ratio = 0.001obtained abs = 85.4759; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990170e+05 Mflops = 377.71 -Solve time = 0.00 -Solve flops = 1.731000e+04 Mflops = 493.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00421717; expected ratio = 0.0001obtained abs = 9.83056e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0489208; expected ratio = 0.001obtained abs = 21.1392; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990170e+05 Mflops = 376.86 -Solve time = 0.00 -Solve flops = 1.731000e+04 Mflops = 511.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00196027; expected ratio = 0.0001obtained abs = 4.57356e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0280406; expected ratio = 0.001obtained abs = 11.9402; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990170e+05 Mflops = 376.18 -Solve time = 0.00 -Solve flops = 1.731000e+04 Mflops = 493.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00141929; expected ratio = 0.0001obtained abs = 3.31368e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0213835; expected ratio = 0.001obtained abs = 9.02449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.990170e+05 Mflops = 377.03 -Solve time = 0.00 -Solve flops = 1.731000e+04 Mflops = 493.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117865; expected ratio = 0.0001obtained abs = 2.75325e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0248762; expected ratio = 0.001obtained abs = 10.4079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.988250e+05 Mflops = 376.49 -Solve time = 0.00 -Solve flops = 1.730000e+04 Mflops = 497.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000909244; expected ratio = 0.0001obtained abs = 2.12473e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.021802; expected ratio = 0.001obtained abs = 9.08627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.979330e+05 Mflops = 375.48 -Solve time = 0.00 -Solve flops = 1.725600e+04 Mflops = 492.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000701787; expected ratio = 0.0001obtained abs = 1.64042e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0147618; expected ratio = 0.001obtained abs = 6.12075; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.994970e+05 Mflops = 379.31 -Solve time = 0.00 -Solve flops = 1.733200e+04 Mflops = 494.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000532762; expected ratio = 0.0001obtained abs = 1.24558e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0191005; expected ratio = 0.001obtained abs = 7.90933; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.999090e+05 Mflops = 378.72 -Solve time = 0.00 -Solve flops = 1.736200e+04 Mflops = 495.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000406533; expected ratio = 0.0001obtained abs = 9.50608e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0607842; expected ratio = 0.001obtained abs = 25.0534; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.000770e+05 Mflops = 378.86 -Solve time = 0.00 -Solve flops = 1.737600e+04 Mflops = 495.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000499159; expected ratio = 0.0001obtained abs = 1.16732e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0476791; expected ratio = 0.001obtained abs = 19.628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.000770e+05 Mflops = 379.72 -Solve time = 0.00 -Solve flops = 1.737600e+04 Mflops = 495.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000587882; expected ratio = 0.0001obtained abs = 1.37501e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0093263; expected ratio = 0.001obtained abs = 3.83306; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467777 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.000770e+05 Mflops = 378.86 -Solve time = 0.00 -Solve flops = 1.737600e+04 Mflops = 509.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000349821; expected ratio = 0.0001obtained abs = 8.18243e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0222952; expected ratio = 0.001obtained abs = 9.17807; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.000770e+05 Mflops = 379.72 -Solve time = 0.00 -Solve flops = 1.737600e+04 Mflops = 499.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162672; expected ratio = 0.0001obtained abs = 3.80508e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0556543; expected ratio = 0.001obtained abs = 22.8064; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.999090e+05 Mflops = 377.86 -Solve time = 0.00 -Solve flops = 1.736200e+04 Mflops = 495.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000184321; expected ratio = 0.0001obtained abs = 4.31163e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0821097; expected ratio = 0.001obtained abs = 33.8792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.006690e+05 Mflops = 379.99 -Solve time = 0.00 -Solve flops = 1.740000e+04 Mflops = 496.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000186289; expected ratio = 0.0001obtained abs = 4.35772e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.24657; expected ratio = 0.001obtained abs = 102.073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.999090e+05 Mflops = 377.86 -Solve time = 0.00 -Solve flops = 1.736200e+04 Mflops = 495.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000465866; expected ratio = 0.0001obtained abs = 1.08979e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.210655; expected ratio = 0.001obtained abs = 86.3086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.999090e+05 Mflops = 379.23 -Solve time = 0.00 -Solve flops = 1.736200e+04 Mflops = 495.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00063064; expected ratio = 0.0001obtained abs = 1.47538e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136151; expected ratio = 0.001obtained abs = 5.57366; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.999090e+05 Mflops = 377.86 -Solve time = 0.00 -Solve flops = 1.736200e+04 Mflops = 495.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00046098; expected ratio = 0.0001obtained abs = 1.07845e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0207818; expected ratio = 0.001obtained abs = 8.52493; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.999090e+05 Mflops = 379.40 -Solve time = 0.00 -Solve flops = 1.736200e+04 Mflops = 495.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000128346; expected ratio = 0.0001obtained abs = 3.0026e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0154245; expected ratio = 0.001obtained abs = 6.31943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84747 - Final Residual ratio : 0.00104799 - Residual ratio : 0.000567255 - Slope : -0.0636698 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.72843 - Final Residual ratio : 0.00129489 - Residual ratio : 0.000749169 - Slope : -0.0690855 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63736 - Final Residual ratio : 0.00139935 - Residual ratio : 0.000854638 - Slope : -0.0511238 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.8191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56821 - Final Residual ratio : 0.00133553 - Residual ratio : 0.000851629 - Slope : -0.0626749 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65317 - Final Residual ratio : 0.00109535 - Residual ratio : 0.000662577 - Slope : -0.0569682 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.46589 - Final Residual ratio : 0.000915737 - Residual ratio : 0.000624699 - Slope : -0.0488324 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4069 - Final Residual ratio : 0.000916709 - Residual ratio : 0.000651579 - Slope : -0.0585828 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35972 - Final Residual ratio : 0.00125657 - Residual ratio : 0.000924137 - Slope : -0.0503135 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31995 - Final Residual ratio : 0.00105181 - Residual ratio : 0.000796856 - Slope : -0.0527557 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.45654 - Final Residual ratio : 0.000955913 - Residual ratio : 0.000656288 - Slope : -0.0559842 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 200 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8251 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.927700e+05 Mflops = 375.71 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 476.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0242505; expected ratio = 0.0001obtained abs = 0.000573571; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0862995; expected ratio = 0.001obtained abs = 36.2434; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.926920e+05 Mflops = 375.74 -Solve time = 0.00 -Solve flops = 1.714800e+04 Mflops = 489.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00695082; expected ratio = 0.0001obtained abs = 0.000163933; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0753504; expected ratio = 0.001obtained abs = 32.8848; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.931100e+05 Mflops = 376.38 -Solve time = 0.00 -Solve flops = 1.716800e+04 Mflops = 476.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00373818; expected ratio = 0.0001obtained abs = 8.80133e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0468769; expected ratio = 0.001obtained abs = 21.0582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.920740e+05 Mflops = 378.76 -Solve time = 0.00 -Solve flops = 1.712200e+04 Mflops = 475.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00287738; expected ratio = 0.0001obtained abs = 6.76529e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0320947; expected ratio = 0.001obtained abs = 14.6958; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000479221 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.910300e+05 Mflops = 377.59 -Solve time = 0.00 -Solve flops = 1.708600e+04 Mflops = 474.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00233595; expected ratio = 0.0001obtained abs = 5.48587e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0305131; expected ratio = 0.001obtained abs = 14.2307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00048089 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.910300e+05 Mflops = 368.89 -Solve time = 0.00 -Solve flops = 1.708600e+04 Mflops = 474.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00183939; expected ratio = 0.0001obtained abs = 4.31583e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0338988; expected ratio = 0.001obtained abs = 15.9686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.899800e+05 Mflops = 375.33 -Solve time = 0.00 -Solve flops = 1.703600e+04 Mflops = 473.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00148926; expected ratio = 0.0001obtained abs = 3.49175e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0558339; expected ratio = 0.001obtained abs = 26.669; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.890480e+05 Mflops = 374.37 -Solve time = 0.00 -Solve flops = 1.703200e+04 Mflops = 473.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0011346; expected ratio = 0.0001obtained abs = 2.65879e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.124434; expected ratio = 0.001obtained abs = 59.6751; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.886600e+05 Mflops = 373.61 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 488.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00084927; expected ratio = 0.0001obtained abs = 1.98931e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100454; expected ratio = 0.001obtained abs = 48.5063; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467777 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.886600e+05 Mflops = 373.61 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 472.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000698162; expected ratio = 0.0001obtained abs = 1.63482e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.040682; expected ratio = 0.001obtained abs = 19.7007; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.886600e+05 Mflops = 372.90 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 485.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000525671; expected ratio = 0.0001obtained abs = 1.23062e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0402667; expected ratio = 0.001obtained abs = 19.5962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475883 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.886600e+05 Mflops = 372.03 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 472.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000419647; expected ratio = 0.0001obtained abs = 9.82225e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0224487; expected ratio = 0.001obtained abs = 10.9425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.886600e+05 Mflops = 364.15 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 472.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000352638; expected ratio = 0.0001obtained abs = 8.25251e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0179877; expected ratio = 0.001obtained abs = 8.79504; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.876100e+05 Mflops = 364.30 -Solve time = 0.00 -Solve flops = 1.694800e+04 Mflops = 470.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00030094; expected ratio = 0.0001obtained abs = 7.04192e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115323; expected ratio = 0.001obtained abs = 5.64594; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.886600e+05 Mflops = 372.73 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 472.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000265058; expected ratio = 0.0001obtained abs = 6.20171e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00577425; expected ratio = 0.001obtained abs = 2.83102; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.882820e+05 Mflops = 372.15 -Solve time = 0.00 -Solve flops = 1.698000e+04 Mflops = 471.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000193277; expected ratio = 0.0001obtained abs = 4.52186e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00317357; expected ratio = 0.001obtained abs = 1.558; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.882820e+05 Mflops = 366.29 -Solve time = 0.00 -Solve flops = 1.698000e+04 Mflops = 471.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000210244; expected ratio = 0.0001obtained abs = 4.91849e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00463011; expected ratio = 0.001obtained abs = 2.275; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.882820e+05 Mflops = 372.68 -Solve time = 0.00 -Solve flops = 1.698000e+04 Mflops = 474.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000286042; expected ratio = 0.0001obtained abs = 6.6915e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0111639; expected ratio = 0.001obtained abs = 5.49139; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.882820e+05 Mflops = 372.86 -Solve time = 0.00 -Solve flops = 1.698000e+04 Mflops = 471.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000314505; expected ratio = 0.0001obtained abs = 7.35703e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0107615; expected ratio = 0.001obtained abs = 5.29555; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.892940e+05 Mflops = 360.56 -Solve time = 0.00 -Solve flops = 1.702400e+04 Mflops = 472.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000254589; expected ratio = 0.0001obtained abs = 5.95523e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0113962; expected ratio = 0.001obtained abs = 5.61031; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.39544 - Final Residual ratio : 0.00280162 - Residual ratio : 0.000825114 - Slope : -0.125653 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.6275 - Final Residual ratio : 0.0139545 - Residual ratio : 0.000892946 - Slope : -0.624543 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.68396 - Final Residual ratio : 0.00633776 - Residual ratio : 0.000948204 - Slope : -0.267105 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.29499 - Final Residual ratio : 0.00344942 - Residual ratio : 0.000803126 - Slope : -0.147984 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.02083 - Final Residual ratio : 0.00345796 - Residual ratio : 0.000860011 - Slope : -0.154514 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.64017 - Final Residual ratio : 0.00314425 - Residual ratio : 0.000863765 - Slope : -0.242468 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.26189 - Final Residual ratio : 0.00245082 - Residual ratio : 0.00075135 - Slope : -0.116409 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.94051 - Final Residual ratio : 0.00247723 - Residual ratio : 0.00084245 - Slope : -0.108816 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.68575 - Final Residual ratio : 0.00264789 - Residual ratio : 0.0009859 - Slope : -0.103196 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.50286 - Final Residual ratio : 0.00206789 - Residual ratio : 0.000826211 - Slope : -0.089314 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 200 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8351 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475883 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.858080e+05 Mflops = 367.26 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 480.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0289651; expected ratio = 0.0001obtained abs = 0.000670538; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0928545; expected ratio = 0.001obtained abs = 42.7741; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.879420e+05 Mflops = 375.91 -Solve time = 0.00 -Solve flops = 1.694800e+04 Mflops = 483.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0128172; expected ratio = 0.0001obtained abs = 0.000298421; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0740127; expected ratio = 0.001obtained abs = 32.8153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.895860e+05 Mflops = 379.02 -Solve time = 0.00 -Solve flops = 1.701400e+04 Mflops = 472.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00377947; expected ratio = 0.0001obtained abs = 8.81035e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0473021; expected ratio = 0.001obtained abs = 20.5123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.885740e+05 Mflops = 382.46 -Solve time = 0.00 -Solve flops = 1.697000e+04 Mflops = 471.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00235297; expected ratio = 0.0001obtained abs = 5.49077e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0295391; expected ratio = 0.001obtained abs = 12.595; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.896240e+05 Mflops = 383.85 -Solve time = 0.00 -Solve flops = 1.702000e+04 Mflops = 485.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00157051; expected ratio = 0.0001obtained abs = 3.66726e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0243386; expected ratio = 0.001obtained abs = 10.2822; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.895360e+05 Mflops = 378.38 -Solve time = 0.00 -Solve flops = 1.701200e+04 Mflops = 485.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0010957; expected ratio = 0.0001obtained abs = 2.55975e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0331752; expected ratio = 0.001obtained abs = 13.8638; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.882760e+05 Mflops = 383.53 -Solve time = 0.00 -Solve flops = 1.695200e+04 Mflops = 470.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000788977; expected ratio = 0.0001obtained abs = 1.84379e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0314583; expected ratio = 0.001obtained abs = 13.1063; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.883640e+05 Mflops = 383.71 -Solve time = 0.00 -Solve flops = 1.696000e+04 Mflops = 471.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000559249; expected ratio = 0.0001obtained abs = 1.30725e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0208689; expected ratio = 0.001obtained abs = 8.64163; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.883640e+05 Mflops = 383.71 -Solve time = 0.00 -Solve flops = 1.696000e+04 Mflops = 471.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000405706; expected ratio = 0.0001obtained abs = 9.485e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0288586; expected ratio = 0.001obtained abs = 11.9502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.883640e+05 Mflops = 383.71 -Solve time = 0.00 -Solve flops = 1.696000e+04 Mflops = 483.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000371893; expected ratio = 0.0001obtained abs = 8.69552e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0615337; expected ratio = 0.001obtained abs = 25.2897; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.883640e+05 Mflops = 382.96 -Solve time = 0.00 -Solve flops = 1.696000e+04 Mflops = 471.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000469709; expected ratio = 0.0001obtained abs = 1.09838e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0507212; expected ratio = 0.001obtained abs = 20.8855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.883640e+05 Mflops = 382.78 -Solve time = 0.00 -Solve flops = 1.696000e+04 Mflops = 471.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000356362; expected ratio = 0.0001obtained abs = 8.33399e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0184844; expected ratio = 0.001obtained abs = 7.58881; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.871240e+05 Mflops = 374.28 -Solve time = 0.00 -Solve flops = 1.689800e+04 Mflops = 469.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000220169; expected ratio = 0.0001obtained abs = 5.14919e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0176368; expected ratio = 0.001obtained abs = 7.24543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.888520e+05 Mflops = 384.70 -Solve time = 0.00 -Solve flops = 1.695200e+04 Mflops = 483.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000196056; expected ratio = 0.0001obtained abs = 4.5854e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0280122; expected ratio = 0.001obtained abs = 11.4693; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.900920e+05 Mflops = 385.54 -Solve time = 0.00 -Solve flops = 1.701400e+04 Mflops = 485.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000156714; expected ratio = 0.0001obtained abs = 3.66536e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0296372; expected ratio = 0.001obtained abs = 12.1614; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000476837 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.900920e+05 Mflops = 385.73 -Solve time = 0.00 -Solve flops = 1.701400e+04 Mflops = 485.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000188855; expected ratio = 0.0001obtained abs = 4.4172e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0303036; expected ratio = 0.001obtained abs = 12.3984; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.900920e+05 Mflops = 386.29 -Solve time = 0.00 -Solve flops = 1.701400e+04 Mflops = 472.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000309053; expected ratio = 0.0001obtained abs = 7.22875e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.035484; expected ratio = 0.001obtained abs = 14.5575; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.888520e+05 Mflops = 383.77 -Solve time = 0.00 -Solve flops = 1.695200e+04 Mflops = 483.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000265525; expected ratio = 0.0001obtained abs = 6.21071e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0431555; expected ratio = 0.001obtained abs = 17.6251; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.900920e+05 Mflops = 387.04 -Solve time = 0.00 -Solve flops = 1.701400e+04 Mflops = 472.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000216405; expected ratio = 0.0001obtained abs = 5.06186e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0402476; expected ratio = 0.001obtained abs = 16.4947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.900920e+05 Mflops = 386.48 -Solve time = 0.00 -Solve flops = 1.701400e+04 Mflops = 485.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000180027; expected ratio = 0.0001obtained abs = 4.211e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.034619; expected ratio = 0.001obtained abs = 14.1444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.32829 - Final Residual ratio : 0.00216909 - Residual ratio : 0.000931622 - Slope : -0.0861528 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.20735 - Final Residual ratio : 0.00215242 - Residual ratio : 0.000975114 - Slope : -0.0918833 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.10801 - Final Residual ratio : 0.00165647 - Residual ratio : 0.000785798 - Slope : -0.0726327 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02332 - Final Residual ratio : 0.00169794 - Residual ratio : 0.000839186 - Slope : -0.0697112 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98518 - Final Residual ratio : 0.00137162 - Residual ratio : 0.000690929 - Slope : -0.066127 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.87858 - Final Residual ratio : 0.00161307 - Residual ratio : 0.000858667 - Slope : -0.064723 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81935 - Final Residual ratio : 0.00170309 - Residual ratio : 0.000936097 - Slope : -0.0649159 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8431 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76465 - Final Residual ratio : 0.00160408 - Residual ratio : 0.000909012 - Slope : -0.125932 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.71468 - Final Residual ratio : 0.00148568 - Residual ratio : 0.000866448 - Slope : -0.0634516 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.6939 - Final Residual ratio : 0.00166369 - Residual ratio : 0.000982168 - Slope : -0.0604369 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 200 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8451 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.007750e+05 Mflops = 405.64 -Solve time = 0.00 -Solve flops = 1.751800e+04 Mflops = 486.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0183085; expected ratio = 0.0001obtained abs = 0.000430892; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103187; expected ratio = 0.001obtained abs = 45.5678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.008970e+05 Mflops = 408.25 -Solve time = 0.00 -Solve flops = 1.752000e+04 Mflops = 427.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0112847; expected ratio = 0.0001obtained abs = 0.000264354; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0723943; expected ratio = 0.001obtained abs = 33.1994; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.019830e+05 Mflops = 409.66 -Solve time = 0.00 -Solve flops = 1.754600e+04 Mflops = 500.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00595347; expected ratio = 0.0001obtained abs = 0.000139201; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0484745; expected ratio = 0.001obtained abs = 22.8683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.006870e+05 Mflops = 408.02 -Solve time = 0.00 -Solve flops = 1.751000e+04 Mflops = 380.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00312033; expected ratio = 0.0001obtained abs = 7.28485e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.027696; expected ratio = 0.001obtained abs = 13.2793; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.011830e+05 Mflops = 408.04 -Solve time = 0.00 -Solve flops = 1.751000e+04 Mflops = 499.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0024039; expected ratio = 0.0001obtained abs = 5.60584e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0226873; expected ratio = 0.001obtained abs = 11.0485; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.019850e+05 Mflops = 408.87 -Solve time = 0.00 -Solve flops = 1.755200e+04 Mflops = 504.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00174356; expected ratio = 0.0001obtained abs = 4.06247e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0148919; expected ratio = 0.001obtained abs = 7.32671; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.019850e+05 Mflops = 408.87 -Solve time = 0.00 -Solve flops = 1.755200e+04 Mflops = 500.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00132129; expected ratio = 0.0001obtained abs = 3.07665e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0120122; expected ratio = 0.001obtained abs = 5.96137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.019850e+05 Mflops = 409.86 -Solve time = 0.00 -Solve flops = 1.755200e+04 Mflops = 500.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000991339; expected ratio = 0.0001obtained abs = 2.30726e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0113063; expected ratio = 0.001obtained abs = 5.64258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.027050e+05 Mflops = 410.33 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 488.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000775302; expected ratio = 0.0001obtained abs = 1.80378e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0151403; expected ratio = 0.001obtained abs = 7.60212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.027050e+05 Mflops = 409.54 -Solve time = 0.00 -Solve flops = 1.758600e+04 Mflops = 501.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000626636; expected ratio = 0.0001obtained abs = 1.45751e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0231535; expected ratio = 0.001obtained abs = 11.647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.021770e+05 Mflops = 408.47 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 501.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000476936; expected ratio = 0.0001obtained abs = 1.10908e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0220067; expected ratio = 0.001obtained abs = 11.1222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.016810e+05 Mflops = 408.46 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 501.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000361652; expected ratio = 0.0001obtained abs = 8.40866e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0138273; expected ratio = 0.001obtained abs = 6.99697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.021770e+05 Mflops = 409.46 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 504.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000288054; expected ratio = 0.0001obtained abs = 6.69651e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0182013; expected ratio = 0.001obtained abs = 9.2426; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.021770e+05 Mflops = 409.26 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 504.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000282664; expected ratio = 0.0001obtained abs = 6.57058e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0304018; expected ratio = 0.001obtained abs = 15.422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.021770e+05 Mflops = 409.26 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 501.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000275541; expected ratio = 0.0001obtained abs = 6.40446e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0269471; expected ratio = 0.001obtained abs = 13.716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.016810e+05 Mflops = 409.05 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 487.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000199688; expected ratio = 0.0001obtained abs = 4.6411e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0134911; expected ratio = 0.001obtained abs = 6.86643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.021770e+05 Mflops = 402.85 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 487.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000165264; expected ratio = 0.0001obtained abs = 3.84079e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115905; expected ratio = 0.001obtained abs = 5.91054; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.016810e+05 Mflops = 408.26 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 501.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000135918; expected ratio = 0.0001obtained abs = 3.15861e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112961; expected ratio = 0.001obtained abs = 5.75944; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000482082 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.021770e+05 Mflops = 409.26 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 504.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000124287; expected ratio = 0.0001obtained abs = 2.88818e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0139972; expected ratio = 0.001obtained abs = 7.15053; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 2.021770e+05 Mflops = 408.47 -Solve time = 0.00 -Solve flops = 1.756000e+04 Mflops = 501.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000150727; expected ratio = 0.0001obtained abs = 3.50247e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0222717; expected ratio = 0.001obtained abs = 11.3623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.62548 - Final Residual ratio : 0.00145128 - Residual ratio : 0.000892829 - Slope : -0.0580012 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.58877 - Final Residual ratio : 0.00147094 - Residual ratio : 0.000925835 - Slope : -0.0566892 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55353 - Final Residual ratio : 0.00136174 - Residual ratio : 0.000876545 - Slope : -0.103478 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52102 - Final Residual ratio : 0.00123366 - Residual ratio : 0.000811075 - Slope : -0.0633246 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50797 - Final Residual ratio : 0.00113054 - Residual ratio : 0.000749709 - Slope : -0.0602737 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.46218 - Final Residual ratio : 0.00125506 - Residual ratio : 0.000858348 - Slope : -0.0503766 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.44092 - Final Residual ratio : 0.00137174 - Residual ratio : 0.00095199 - Slope : -0.0514125 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41912 - Final Residual ratio : 0.00136878 - Residual ratio : 0.000964522 - Slope : -0.0567101 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.39747 - Final Residual ratio : 0.00139454 - Residual ratio : 0.000997907 - Slope : -0.0775596 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.39177 - Final Residual ratio : 0.00121962 - Residual ratio : 0.000876304 - Slope : -0.0817973 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 200 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8551 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000477076 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.781740e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.650400e+04 Mflops = 470.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0360389; expected ratio = 0.0001obtained abs = 0.000822575; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.14283; expected ratio = 0.001obtained abs = 66.2403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.799540e+05 Mflops = 364.28 -Solve time = 0.00 -Solve flops = 1.660600e+04 Mflops = 487.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0201382; expected ratio = 0.0001obtained abs = 0.000463839; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0579477; expected ratio = 0.001obtained abs = 25.9172; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.783980e+05 Mflops = 361.83 -Solve time = 0.00 -Solve flops = 1.652400e+04 Mflops = 484.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00575678; expected ratio = 0.0001obtained abs = 0.000132659; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0377278; expected ratio = 0.001obtained abs = 16.4992; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.780300e+05 Mflops = 361.25 -Solve time = 0.00 -Solve flops = 1.651200e+04 Mflops = 484.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0021986; expected ratio = 0.0001obtained abs = 5.07129e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0239743; expected ratio = 0.001obtained abs = 10.3435; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.800800e+05 Mflops = 364.53 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 490.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129514; expected ratio = 0.0001obtained abs = 2.98894e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187306; expected ratio = 0.001obtained abs = 8.01913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.780300e+05 Mflops = 359.00 -Solve time = 0.00 -Solve flops = 1.651200e+04 Mflops = 484.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000805254; expected ratio = 0.0001obtained abs = 1.85899e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0181946; expected ratio = 0.001obtained abs = 7.73142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00047183 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.804740e+05 Mflops = 363.92 -Solve time = 0.00 -Solve flops = 1.663200e+04 Mflops = 487.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000527283; expected ratio = 0.0001obtained abs = 1.21753e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01625; expected ratio = 0.001obtained abs = 6.88874; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.817080e+05 Mflops = 366.41 -Solve time = 0.00 -Solve flops = 1.669400e+04 Mflops = 489.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000383481; expected ratio = 0.0001obtained abs = 8.85595e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0175796; expected ratio = 0.001obtained abs = 7.42104; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.809100e+05 Mflops = 365.51 -Solve time = 0.00 -Solve flops = 1.665600e+04 Mflops = 488.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000303611; expected ratio = 0.0001obtained abs = 7.01216e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0193638; expected ratio = 0.001obtained abs = 8.17306; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.800300e+05 Mflops = 364.43 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 490.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000272061; expected ratio = 0.0001obtained abs = 6.28385e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0217241; expected ratio = 0.001obtained abs = 9.14107; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.800300e+05 Mflops = 363.73 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 490.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000256184; expected ratio = 0.0001obtained abs = 5.91744e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0205225; expected ratio = 0.001obtained abs = 8.64198; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 365.85 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 488.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000219646; expected ratio = 0.0001obtained abs = 5.0736e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0204455; expected ratio = 0.001obtained abs = 8.59049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.819600e+05 Mflops = 367.63 -Solve time = 0.00 -Solve flops = 1.670600e+04 Mflops = 490.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000232367; expected ratio = 0.0001obtained abs = 5.36761e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0223344; expected ratio = 0.001obtained abs = 9.39661; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.800300e+05 Mflops = 362.85 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 490.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000220771; expected ratio = 0.0001obtained abs = 5.09977e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0235267; expected ratio = 0.001obtained abs = 9.87764; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.800300e+05 Mflops = 355.68 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 490.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000227861; expected ratio = 0.0001obtained abs = 5.26364e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0215253; expected ratio = 0.001obtained abs = 9.05023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 365.85 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 488.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000201709; expected ratio = 0.0001obtained abs = 4.65954e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0206465; expected ratio = 0.001obtained abs = 8.66618; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 366.56 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 492.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000213644; expected ratio = 0.0001obtained abs = 4.93529e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0225344; expected ratio = 0.001obtained abs = 9.4739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 365.85 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 492.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000211814; expected ratio = 0.0001obtained abs = 4.89299e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234728; expected ratio = 0.001obtained abs = 9.8507; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 367.27 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 492.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00021437; expected ratio = 0.0001obtained abs = 4.95208e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0214602; expected ratio = 0.001obtained abs = 9.01998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.810800e+05 Mflops = 365.85 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 488.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000197502; expected ratio = 0.0001obtained abs = 4.56239e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0205659; expected ratio = 0.001obtained abs = 8.63084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.83894 - Final Residual ratio : 0.00377676 - Residual ratio : 0.000983804 - Slope : -0.239698 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.78864 - Final Residual ratio : 0.0027172 - Residual ratio : 0.000567426 - Slope : -0.165032 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.39104 - Final Residual ratio : 0.00514412 - Residual ratio : 0.000954197 - Slope : -0.185721 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.25534 - Final Residual ratio : 0.0030852 - Residual ratio : 0.00058706 - Slope : -0.175075 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.61708 - Final Residual ratio : 0.0039365 - Residual ratio : 0.000852595 - Slope : -0.159074 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.00569 - Final Residual ratio : 0.00425295 - Residual ratio : 0.00060707 - Slope : -0.280058 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.7845 - Final Residual ratio : 0.00667437 - Residual ratio : 0.000983768 - Slope : -0.242065 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.32708 - Final Residual ratio : 0.00226667 - Residual ratio : 0.000681279 - Slope : -0.114649 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.05168 - Final Residual ratio : 0.00222545 - Residual ratio : 0.000729256 - Slope : -0.105153 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.79061 - Final Residual ratio : 0.00217861 - Residual ratio : 0.000780692 - Slope : -0.0961529 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 200 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8651 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475168 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675940e+05 Mflops = 351.29 -Solve time = 0.00 -Solve flops = 1.617200e+04 Mflops = 474.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0208576; expected ratio = 0.0001obtained abs = 0.00048225; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0985142; expected ratio = 0.001obtained abs = 44.0464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475883 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.670520e+05 Mflops = 352.45 -Solve time = 0.00 -Solve flops = 1.613800e+04 Mflops = 473.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0141186; expected ratio = 0.0001obtained abs = 0.000325111; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0632848; expected ratio = 0.001obtained abs = 29.0672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.643580e+05 Mflops = 337.43 -Solve time = 0.00 -Solve flops = 1.600800e+04 Mflops = 469.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0050308; expected ratio = 0.0001obtained abs = 0.000115676; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0386114; expected ratio = 0.001obtained abs = 18.0852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.652820e+05 Mflops = 348.71 -Solve time = 0.00 -Solve flops = 1.605200e+04 Mflops = 484.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00243861; expected ratio = 0.0001obtained abs = 5.60149e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211159; expected ratio = 0.001obtained abs = 9.99252; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.652820e+05 Mflops = 348.71 -Solve time = 0.00 -Solve flops = 1.605200e+04 Mflops = 484.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00159207; expected ratio = 0.0001obtained abs = 3.65449e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.017148; expected ratio = 0.001obtained abs = 8.19753; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.663320e+05 Mflops = 350.93 -Solve time = 0.00 -Solve flops = 1.610200e+04 Mflops = 489.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107999; expected ratio = 0.0001obtained abs = 2.47783e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0121274; expected ratio = 0.001obtained abs = 5.832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.663320e+05 Mflops = 350.93 -Solve time = 0.00 -Solve flops = 1.610200e+04 Mflops = 472.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000766341; expected ratio = 0.0001obtained abs = 1.7576e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106294; expected ratio = 0.001obtained abs = 5.14022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.663320e+05 Mflops = 350.93 -Solve time = 0.00 -Solve flops = 1.610200e+04 Mflops = 489.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000563485; expected ratio = 0.0001obtained abs = 1.29203e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00943519; expected ratio = 0.001obtained abs = 4.57663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 352.08 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 487.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000417346; expected ratio = 0.0001obtained abs = 9.56754e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0138647; expected ratio = 0.001obtained abs = 6.75138; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000589848 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 352.79 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 490.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000376321; expected ratio = 0.0001obtained abs = 8.62599e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0190045; expected ratio = 0.001obtained abs = 9.25799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.661620e+05 Mflops = 350.57 -Solve time = 0.00 -Solve flops = 1.609600e+04 Mflops = 489.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000297496; expected ratio = 0.0001obtained abs = 6.81843e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018076; expected ratio = 0.001obtained abs = 8.8331; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.661620e+05 Mflops = 350.57 -Solve time = 0.00 -Solve flops = 1.609600e+04 Mflops = 489.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0002452; expected ratio = 0.0001obtained abs = 5.61943e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0143378; expected ratio = 0.001obtained abs = 7.00643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 352.79 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 487.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000206914; expected ratio = 0.0001obtained abs = 4.7417e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.013264; expected ratio = 0.001obtained abs = 6.49565; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 352.08 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 490.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000182731; expected ratio = 0.0001obtained abs = 4.18732e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122434; expected ratio = 0.001obtained abs = 5.99419; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 351.90 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 490.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000166913; expected ratio = 0.0001obtained abs = 3.82469e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118936; expected ratio = 0.001obtained abs = 5.83305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 352.08 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 473.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000155568; expected ratio = 0.0001obtained abs = 3.56463e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.011626; expected ratio = 0.001obtained abs = 5.69899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 347.03 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 473.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000151181; expected ratio = 0.0001obtained abs = 3.46401e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116603; expected ratio = 0.001obtained abs = 5.72459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 352.08 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 473.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000146998; expected ratio = 0.0001obtained abs = 3.3681e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116783; expected ratio = 0.001obtained abs = 5.72961; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 352.79 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 487.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000147492; expected ratio = 0.0001obtained abs = 3.37936e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118473; expected ratio = 0.001obtained abs = 5.82094; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 352.08 -Solve time = 0.00 -Solve flops = 1.614600e+04 Mflops = 487.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000146105; expected ratio = 0.0001obtained abs = 3.34752e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119627; expected ratio = 0.001obtained abs = 5.87303; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.35392 - Final Residual ratio : 0.00131674 - Residual ratio : 0.000559385 - Slope : -0.07842 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.04716 - Final Residual ratio : 0.00170413 - Residual ratio : 0.000832435 - Slope : -0.0705329 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.97767 - Final Residual ratio : 0.0017934 - Residual ratio : 0.000906822 - Slope : -0.0790352 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05281 - Final Residual ratio : 0.00122262 - Residual ratio : 0.000595584 - Slope : -0.0661803 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.13887 - Final Residual ratio : 0.00173292 - Residual ratio : 0.000810206 - Slope : -0.0712378 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03163 - Final Residual ratio : 0.000877772 - Residual ratio : 0.000432053 - Slope : -0.0676917 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.9129 - Final Residual ratio : 0.00109001 - Residual ratio : 0.00056982 - Slope : -0.0637269 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80118 - Final Residual ratio : 0.00155458 - Residual ratio : 0.000863092 - Slope : -0.0642722 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.72384 - Final Residual ratio : 0.00116094 - Residual ratio : 0.000673461 - Slope : -0.0574227 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.69027 - Final Residual ratio : 0.00147435 - Residual ratio : 0.000872257 - Slope : -0.0582342 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 123 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 200 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8751 -matrix_partition : [5](0,49,98,147,196) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000477076 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.679480e+05 Mflops = 352.74 -Solve time = 0.00 -Solve flops = 1.618200e+04 Mflops = 477.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0311729; expected ratio = 0.0001obtained abs = 0.000702602; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11015; expected ratio = 0.001obtained abs = 50.2896; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.667120e+05 Mflops = 351.73 -Solve time = 0.00 -Solve flops = 1.612600e+04 Mflops = 486.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.017084; expected ratio = 0.0001obtained abs = 0.000387827; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0455141; expected ratio = 0.001obtained abs = 20.3581; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672420e+05 Mflops = 352.14 -Solve time = 0.00 -Solve flops = 1.614800e+04 Mflops = 476.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00430899; expected ratio = 0.0001obtained abs = 9.78055e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0249168; expected ratio = 0.001obtained abs = 11.0456; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672420e+05 Mflops = 352.14 -Solve time = 0.00 -Solve flops = 1.614800e+04 Mflops = 487.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00114131; expected ratio = 0.0001obtained abs = 2.59167e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0209371; expected ratio = 0.001obtained abs = 9.22089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672420e+05 Mflops = 351.96 -Solve time = 0.00 -Solve flops = 1.614800e+04 Mflops = 476.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000654851; expected ratio = 0.0001obtained abs = 1.48738e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0184186; expected ratio = 0.001obtained abs = 8.093; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.674460e+05 Mflops = 353.28 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 477.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000427114; expected ratio = 0.0001obtained abs = 9.70248e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0180517; expected ratio = 0.001obtained abs = 7.8991; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.672120e+05 Mflops = 352.79 -Solve time = 0.00 -Solve flops = 1.614400e+04 Mflops = 473.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000303355; expected ratio = 0.0001obtained abs = 6.89174e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0171756; expected ratio = 0.001obtained abs = 7.51653; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.669780e+05 Mflops = 352.29 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 473.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00026012; expected ratio = 0.0001obtained abs = 5.90983e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0172517; expected ratio = 0.001obtained abs = 7.52974; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.669780e+05 Mflops = 352.29 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 473.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000211924; expected ratio = 0.0001obtained abs = 4.81502e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0171645; expected ratio = 0.001obtained abs = 7.49871; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675600e+05 Mflops = 353.52 -Solve time = 0.00 -Solve flops = 1.616200e+04 Mflops = 474.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00020989; expected ratio = 0.0001obtained abs = 4.76891e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0174071; expected ratio = 0.001obtained abs = 7.58913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675600e+05 Mflops = 354.41 -Solve time = 0.00 -Solve flops = 1.616200e+04 Mflops = 487.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000190958; expected ratio = 0.0001obtained abs = 4.33883e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0176098; expected ratio = 0.001obtained abs = 7.68766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675420e+05 Mflops = 353.48 -Solve time = 0.00 -Solve flops = 1.615800e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00018921; expected ratio = 0.0001obtained abs = 4.29915e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0179425; expected ratio = 0.001obtained abs = 7.81864; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.684840e+05 Mflops = 352.46 -Solve time = 0.00 -Solve flops = 1.620600e+04 Mflops = 478.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000185956; expected ratio = 0.0001obtained abs = 4.22528e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0181848; expected ratio = 0.001obtained abs = 7.93642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675420e+05 Mflops = 353.48 -Solve time = 0.00 -Solve flops = 1.615800e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000180272; expected ratio = 0.0001obtained abs = 4.09613e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0185082; expected ratio = 0.001obtained abs = 8.06352; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675420e+05 Mflops = 354.19 -Solve time = 0.00 -Solve flops = 1.615800e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000198536; expected ratio = 0.0001obtained abs = 4.51115e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0214307; expected ratio = 0.001obtained abs = 9.35495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675420e+05 Mflops = 353.48 -Solve time = 0.00 -Solve flops = 1.615800e+04 Mflops = 473.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0002113; expected ratio = 0.0001obtained abs = 4.80115e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0237891; expected ratio = 0.001obtained abs = 10.362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.676860e+05 Mflops = 353.79 -Solve time = 0.00 -Solve flops = 1.616800e+04 Mflops = 491.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00021416; expected ratio = 0.0001obtained abs = 4.86618e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0220547; expected ratio = 0.001obtained abs = 9.62565; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675420e+05 Mflops = 353.48 -Solve time = 0.00 -Solve flops = 1.615800e+04 Mflops = 477.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000193062; expected ratio = 0.0001obtained abs = 4.38678e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0207965; expected ratio = 0.001obtained abs = 9.05973; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000475883 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675420e+05 Mflops = 353.48 -Solve time = 0.00 -Solve flops = 1.615800e+04 Mflops = 473.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000190224; expected ratio = 0.0001obtained abs = 4.3223e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0201431; expected ratio = 0.001obtained abs = 8.79136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 196 -RHS size in solver: 196 -Factor time = 0.00 -Factor flops = 1.675420e+05 Mflops = 344.81 -Solve time = 0.00 -Solve flops = 1.615800e+04 Mflops = 491.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000178722; expected ratio = 0.0001obtained abs = 4.06094e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0197372; expected ratio = 0.001obtained abs = 8.59924; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56644 - Final Residual ratio : 0.00106128 - Residual ratio : 0.000677513 - Slope : -0.0521792 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.46352 - Final Residual ratio : 0.000840451 - Residual ratio : 0.000574268 - Slope : -0.0487559 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38988 - Final Residual ratio : 0.00132986 - Residual ratio : 0.000956817 - Slope : -0.0555418 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.3698 - Final Residual ratio : 0.00102181 - Residual ratio : 0.000745951 - Slope : -0.045626 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34585 - Final Residual ratio : 0.00123088 - Residual ratio : 0.000914576 - Slope : -0.0448205 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38899 - Final Residual ratio : 0.000986822 - Residual ratio : 0.000710462 - Slope : -0.0447742 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37677 - Final Residual ratio : 0.00136093 - Residual ratio : 0.000988497 - Slope : -0.045847 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34448 - Final Residual ratio : 0.00119109 - Residual ratio : 0.000885909 - Slope : -0.0447764 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31005 - Final Residual ratio : 0.00124892 - Residual ratio : 0.000953337 - Slope : -0.0727113 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24245 - Final Residual ratio : 0.00114597 - Residual ratio : 0.000922346 - Slope : -0.0443322 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8851 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.728970e+05 Mflops = 352.03 -Solve time = 0.00 -Solve flops = 1.626400e+04 Mflops = 480.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0220056; expected ratio = 0.0001obtained abs = 0.000497597; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0925191; expected ratio = 0.001obtained abs = 42.3873; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.740490e+05 Mflops = 365.74 -Solve time = 0.00 -Solve flops = 1.631800e+04 Mflops = 478.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0118771; expected ratio = 0.0001obtained abs = 0.000267911; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0732639; expected ratio = 0.001obtained abs = 33.971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453234 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 362.59 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 489.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00423766; expected ratio = 0.0001obtained abs = 9.55596e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0419757; expected ratio = 0.001obtained abs = 19.5256; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 362.59 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 478.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129504; expected ratio = 0.0001obtained abs = 2.91968e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0174122; expected ratio = 0.001obtained abs = 8.10717; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 361.87 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 475.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000773091; expected ratio = 0.0001obtained abs = 1.74267e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0125315; expected ratio = 0.001obtained abs = 5.85571; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 362.59 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 475.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000496111; expected ratio = 0.0001obtained abs = 1.11817e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00900062; expected ratio = 0.001obtained abs = 4.2086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 361.68 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 492.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000358826; expected ratio = 0.0001obtained abs = 8.0868e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0109437; expected ratio = 0.001obtained abs = 5.12721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.728610e+05 Mflops = 361.61 -Solve time = 0.00 -Solve flops = 1.626200e+04 Mflops = 494.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000282594; expected ratio = 0.0001obtained abs = 6.36849e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0186808; expected ratio = 0.001obtained abs = 8.74351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 358.09 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 475.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000218577; expected ratio = 0.0001obtained abs = 4.92563e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0186508; expected ratio = 0.001obtained abs = 8.74444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.728610e+05 Mflops = 362.33 -Solve time = 0.00 -Solve flops = 1.626200e+04 Mflops = 494.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000172499; expected ratio = 0.0001obtained abs = 3.88723e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0139206; expected ratio = 0.001obtained abs = 6.51965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.727410e+05 Mflops = 363.72 -Solve time = 0.00 -Solve flops = 1.625600e+04 Mflops = 476.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000146891; expected ratio = 0.0001obtained abs = 3.3101e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0208913; expected ratio = 0.001obtained abs = 9.80089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.727410e+05 Mflops = 363.72 -Solve time = 0.00 -Solve flops = 1.625600e+04 Mflops = 494.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000184559; expected ratio = 0.0001obtained abs = 4.15899e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0467683; expected ratio = 0.001obtained abs = 21.8639; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 362.59 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 478.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000206566; expected ratio = 0.0001obtained abs = 4.65493e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.050074; expected ratio = 0.001obtained abs = 23.4932; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.737410e+05 Mflops = 364.18 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 481.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000239535; expected ratio = 0.0001obtained abs = 5.39794e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0598026; expected ratio = 0.001obtained abs = 27.9394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 361.87 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 492.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000301485; expected ratio = 0.0001obtained abs = 6.79409e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0608746; expected ratio = 0.001obtained abs = 28.5238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 354.22 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 478.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000289635; expected ratio = 0.0001obtained abs = 6.52726e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0372772; expected ratio = 0.001obtained abs = 17.4128; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.718610e+05 Mflops = 361.87 -Solve time = 0.00 -Solve flops = 1.621200e+04 Mflops = 489.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000237967; expected ratio = 0.0001obtained abs = 5.36289e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0285794; expected ratio = 0.001obtained abs = 13.3783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.728610e+05 Mflops = 363.97 -Solve time = 0.00 -Solve flops = 1.626200e+04 Mflops = 476.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000176542; expected ratio = 0.0001obtained abs = 3.97862e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0197386; expected ratio = 0.001obtained abs = 9.22213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.727410e+05 Mflops = 363.72 -Solve time = 0.00 -Solve flops = 1.625600e+04 Mflops = 494.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000133985; expected ratio = 0.0001obtained abs = 3.01955e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0271349; expected ratio = 0.001obtained abs = 12.7051; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.727410e+05 Mflops = 364.27 -Solve time = 0.00 -Solve flops = 1.625600e+04 Mflops = 480.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00016461; expected ratio = 0.0001obtained abs = 3.70978e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.061627; expected ratio = 0.001obtained abs = 28.7275; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.52426 - Final Residual ratio : 0.0035067 - Residual ratio : 0.000634781 - Slope : -0.184025 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.68542 - Final Residual ratio : 0.00484309 - Residual ratio : 0.000630165 - Slope : -0.264848 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.47638 - Final Residual ratio : 0.00554618 - Residual ratio : 0.000654309 - Slope : -0.292098 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.05481 - Final Residual ratio : 0.00751989 - Residual ratio : 0.00093359 - Slope : -0.277493 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8901 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.94173 - Final Residual ratio : 0.00381427 - Residual ratio : 0.00054947 - Slope : -0.231264 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.60324 - Final Residual ratio : 0.00351418 - Residual ratio : 0.00062717 - Slope : -0.186657 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.58511 - Final Residual ratio : 0.00357105 - Residual ratio : 0.000778835 - Slope : -0.169687 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.25664 - Final Residual ratio : 0.00390678 - Residual ratio : 0.000917808 - Slope : -0.146646 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.25029 - Final Residual ratio : 0.00258012 - Residual ratio : 0.000607046 - Slope : -0.14159 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.02575 - Final Residual ratio : 0.00226325 - Residual ratio : 0.000562194 - Slope : -0.134116 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.8951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.8951 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000487089 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.714250e+05 Mflops = 361.67 -Solve time = 0.00 -Solve flops = 1.619800e+04 Mflops = 478.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0266066; expected ratio = 0.0001obtained abs = 0.000592395; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105451; expected ratio = 0.001obtained abs = 46.7187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.707930e+05 Mflops = 363.26 -Solve time = 0.00 -Solve flops = 1.616400e+04 Mflops = 491.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0119947; expected ratio = 0.0001obtained abs = 0.000268087; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0306474; expected ratio = 0.001obtained abs = 13.6336; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.716330e+05 Mflops = 365.24 -Solve time = 0.00 -Solve flops = 1.620600e+04 Mflops = 492.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00281937; expected ratio = 0.0001obtained abs = 6.2971e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0149445; expected ratio = 0.001obtained abs = 6.69179; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.726330e+05 Mflops = 357.39 -Solve time = 0.00 -Solve flops = 1.625600e+04 Mflops = 476.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000826146; expected ratio = 0.0001obtained abs = 1.84487e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100246; expected ratio = 0.001obtained abs = 4.50915; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.726330e+05 Mflops = 365.69 -Solve time = 0.00 -Solve flops = 1.625600e+04 Mflops = 490.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000404803; expected ratio = 0.0001obtained abs = 9.03816e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00615889; expected ratio = 0.001obtained abs = 2.77965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.717930e+05 Mflops = 364.65 -Solve time = 0.00 -Solve flops = 1.621400e+04 Mflops = 492.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000297158; expected ratio = 0.0001obtained abs = 6.63395e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00654943; expected ratio = 0.001obtained abs = 2.96183; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.717930e+05 Mflops = 365.58 -Solve time = 0.00 -Solve flops = 1.621400e+04 Mflops = 492.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000239953; expected ratio = 0.0001obtained abs = 5.35635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0109304; expected ratio = 0.001obtained abs = 4.95663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.717930e+05 Mflops = 365.58 -Solve time = 0.00 -Solve flops = 1.621400e+04 Mflops = 492.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000210387; expected ratio = 0.0001obtained abs = 4.69607e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0201676; expected ratio = 0.001obtained abs = 9.14338; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.717930e+05 Mflops = 364.84 -Solve time = 0.00 -Solve flops = 1.621400e+04 Mflops = 489.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000208691; expected ratio = 0.0001obtained abs = 4.65793e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.031815; expected ratio = 0.001obtained abs = 14.476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.717930e+05 Mflops = 365.58 -Solve time = 0.00 -Solve flops = 1.621400e+04 Mflops = 492.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000202921; expected ratio = 0.0001obtained abs = 4.52903e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0956067; expected ratio = 0.001obtained abs = 43.3596; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.747570e+05 Mflops = 369.63 -Solve time = 0.00 -Solve flops = 1.636000e+04 Mflops = 479.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00161557; expected ratio = 0.0001obtained abs = 3.60583e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0808334; expected ratio = 0.001obtained abs = 36.7938; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.711930e+05 Mflops = 364.12 -Solve time = 0.00 -Solve flops = 1.618400e+04 Mflops = 491.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00106438; expected ratio = 0.0001obtained abs = 2.3754e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00563774; expected ratio = 0.001obtained abs = 2.56694; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.711930e+05 Mflops = 358.12 -Solve time = 0.00 -Solve flops = 1.618400e+04 Mflops = 491.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000569031; expected ratio = 0.0001obtained abs = 1.26991e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00855327; expected ratio = 0.001obtained abs = 3.89613; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.723130e+05 Mflops = 365.20 -Solve time = 0.00 -Solve flops = 1.624000e+04 Mflops = 476.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000302288; expected ratio = 0.0001obtained abs = 6.74617e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00637607; expected ratio = 0.001obtained abs = 2.90552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.723130e+05 Mflops = 365.20 -Solve time = 0.00 -Solve flops = 1.624000e+04 Mflops = 490.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000347584; expected ratio = 0.0001obtained abs = 7.75686e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0117031; expected ratio = 0.001obtained abs = 5.32724; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.711930e+05 Mflops = 365.04 -Solve time = 0.00 -Solve flops = 1.618400e+04 Mflops = 488.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000308295; expected ratio = 0.0001obtained abs = 6.88026e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112898; expected ratio = 0.001obtained abs = 5.14586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.721930e+05 Mflops = 366.24 -Solve time = 0.00 -Solve flops = 1.623400e+04 Mflops = 493.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000301699; expected ratio = 0.0001obtained abs = 6.73292e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0185575; expected ratio = 0.001obtained abs = 8.44421; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.717930e+05 Mflops = 365.39 -Solve time = 0.00 -Solve flops = 1.621400e+04 Mflops = 492.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0002865; expected ratio = 0.0001obtained abs = 6.39392e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0149567; expected ratio = 0.001obtained abs = 6.81392; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453234 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.717930e+05 Mflops = 356.36 -Solve time = 0.00 -Solve flops = 1.621400e+04 Mflops = 478.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00024846; expected ratio = 0.0001obtained abs = 5.54485e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00882126; expected ratio = 0.001obtained abs = 4.01529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.717930e+05 Mflops = 365.58 -Solve time = 0.00 -Solve flops = 1.621400e+04 Mflops = 489.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000203274; expected ratio = 0.0001obtained abs = 4.53656e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00754612; expected ratio = 0.001obtained abs = 3.43333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.8961 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.43553 - Final Residual ratio : 0.00360026 - Residual ratio : 0.000559434 - Slope : -0.214398 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.51116 - Final Residual ratio : 0.0069173 - Residual ratio : 0.000727282 - Slope : -0.339437 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.7511 - Final Residual ratio : 0.00545115 - Residual ratio : 0.000507032 - Slope : -0.370539 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.8991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4717 - Final Residual ratio : 0.00734607 - Residual ratio : 0.000701517 - Slope : -0.36084 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.8991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9001 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.27187 - Final Residual ratio : 0.00750136 - Residual ratio : 0.000809044 - Slope : -0.319461 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.71585 - Final Residual ratio : 0.00730247 - Residual ratio : 0.000946425 - Slope : -0.275305 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.34614 - Final Residual ratio : 0.00465807 - Residual ratio : 0.000734 - Slope : -0.218672 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.61618 - Final Residual ratio : 0.00372552 - Residual ratio : 0.000663355 - Slope : -0.193533 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.39575 - Final Residual ratio : 0.0037882 - Residual ratio : 0.00070207 - Slope : -0.18593 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.15783 - Final Residual ratio : 0.00326984 - Residual ratio : 0.000633957 - Slope : -0.177743 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9051 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.151400e+05 Mflops = 416.03 -Solve time = 0.00 -Solve flops = 1.799000e+04 Mflops = 499.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0243207; expected ratio = 0.0001obtained abs = 0.000537037; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0643797; expected ratio = 0.001obtained abs = 29.7846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.151400e+05 Mflops = 412.23 -Solve time = 0.00 -Solve flops = 1.799000e+04 Mflops = 513.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00794694; expected ratio = 0.0001obtained abs = 0.000175406; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0694149; expected ratio = 0.001obtained abs = 32.14; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.158540e+05 Mflops = 418.18 -Solve time = 0.00 -Solve flops = 1.802400e+04 Mflops = 514.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00290267; expected ratio = 0.0001obtained abs = 6.40653e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0424959; expected ratio = 0.001obtained abs = 19.6239; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.158540e+05 Mflops = 420.12 -Solve time = 0.00 -Solve flops = 1.802400e+04 Mflops = 500.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000780975; expected ratio = 0.0001obtained abs = 1.72379e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122282; expected ratio = 0.001obtained abs = 5.63222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.158540e+05 Mflops = 418.18 -Solve time = 0.00 -Solve flops = 1.802400e+04 Mflops = 517.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000376594; expected ratio = 0.0001obtained abs = 8.31297e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00667934; expected ratio = 0.001obtained abs = 3.07468; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 419.92 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000185988; expected ratio = 0.0001obtained abs = 4.10569e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00285185; expected ratio = 0.001obtained abs = 1.31129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 410.42 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 488.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00014077; expected ratio = 0.0001obtained abs = 3.10762e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00184542; expected ratio = 0.001obtained abs = 0.848057; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 419.92 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 514.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000115623; expected ratio = 0.0001obtained abs = 2.55254e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00478908; expected ratio = 0.001obtained abs = 2.20071; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 418.95 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 453.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000177082; expected ratio = 0.0001obtained abs = 3.90942e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00985739; expected ratio = 0.001obtained abs = 4.52552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 420.70 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000185247; expected ratio = 0.0001obtained abs = 4.08969e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0117886; expected ratio = 0.001obtained abs = 5.41615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 421.48 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000189976; expected ratio = 0.0001obtained abs = 4.19415e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115829; expected ratio = 0.001obtained abs = 5.31654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 420.70 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000181836; expected ratio = 0.0001obtained abs = 4.01445e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0123327; expected ratio = 0.001obtained abs = 5.66628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 421.48 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 514.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000213386; expected ratio = 0.0001obtained abs = 4.71098e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142138; expected ratio = 0.001obtained abs = 6.52329; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 421.48 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 514.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000239271; expected ratio = 0.0001obtained abs = 5.28248e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0153631; expected ratio = 0.001obtained abs = 7.05983; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 419.92 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000256658; expected ratio = 0.0001obtained abs = 5.66633e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0163496; expected ratio = 0.001obtained abs = 7.50362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 419.92 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000287001; expected ratio = 0.0001obtained abs = 6.33622e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170696; expected ratio = 0.001obtained abs = 7.84582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 420.70 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000293246; expected ratio = 0.0001obtained abs = 6.47404e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.017925; expected ratio = 0.001obtained abs = 8.22753; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 419.92 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000315725; expected ratio = 0.0001obtained abs = 6.97035e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0179471; expected ratio = 0.001obtained abs = 8.25078; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 421.68 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000307537; expected ratio = 0.0001obtained abs = 6.7895e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0180358; expected ratio = 0.001obtained abs = 8.28015; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.162540e+05 Mflops = 418.95 -Solve time = 0.00 -Solve flops = 1.804400e+04 Mflops = 501.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000317648; expected ratio = 0.0001obtained abs = 7.01275e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0177064; expected ratio = 0.001obtained abs = 8.14171; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.6799 - Final Residual ratio : 0.00450739 - Residual ratio : 0.000963138 - Slope : -0.166978 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.14631 - Final Residual ratio : 0.00320886 - Residual ratio : 0.000773909 - Slope : -0.147968 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.91486 - Final Residual ratio : 0.00276754 - Residual ratio : 0.000706932 - Slope : -0.130403 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.99772 - Final Residual ratio : 0.00250146 - Residual ratio : 0.000625722 - Slope : -0.133174 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.04318 - Final Residual ratio : 0.00223671 - Residual ratio : 0.000553205 - Slope : -0.134698 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.87252 - Final Residual ratio : 0.00334437 - Residual ratio : 0.000863616 - Slope : -0.13342 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5277 - Final Residual ratio : 0.00306683 - Residual ratio : 0.000869357 - Slope : -0.121539 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.26197 - Final Residual ratio : 0.00275856 - Residual ratio : 0.000845675 - Slope : -0.10185 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.19236 - Final Residual ratio : 0.00219152 - Residual ratio : 0.000686488 - Slope : -0.106339 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.15458 - Final Residual ratio : 0.00194765 - Residual ratio : 0.000617405 - Slope : -0.105088 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9151 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.056050e+05 Mflops = 416.20 -Solve time = 0.00 -Solve flops = 1.743000e+04 Mflops = 497.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0291102; expected ratio = 0.0001obtained abs = 0.000633673; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0576849; expected ratio = 0.001obtained abs = 25.9462; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.00 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.011607; expected ratio = 0.0001obtained abs = 0.000253555; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0339825; expected ratio = 0.001obtained abs = 15.3487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00208895; expected ratio = 0.0001obtained abs = 4.56046e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0257051; expected ratio = 0.001obtained abs = 11.6755; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 411.38 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000603977; expected ratio = 0.0001obtained abs = 1.31847e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211851; expected ratio = 0.001obtained abs = 9.63592; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 420.85 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000492526; expected ratio = 0.0001obtained abs = 1.07508e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0189186; expected ratio = 0.001obtained abs = 8.62965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 499.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000385815; expected ratio = 0.0001obtained abs = 8.42107e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0176953; expected ratio = 0.001obtained abs = 8.0731; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00040314; expected ratio = 0.0001obtained abs = 8.79871e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0173079; expected ratio = 0.001obtained abs = 7.91454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.00 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000379106; expected ratio = 0.0001obtained abs = 8.2739e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170063; expected ratio = 0.001obtained abs = 7.77458; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000385269; expected ratio = 0.0001obtained abs = 8.40804e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0171425; expected ratio = 0.001obtained abs = 7.85221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 410.59 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000379341; expected ratio = 0.0001obtained abs = 8.27852e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0171515; expected ratio = 0.001obtained abs = 7.85221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 499.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000382381; expected ratio = 0.0001obtained abs = 8.3446e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0174191; expected ratio = 0.001obtained abs = 7.98884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 420.64 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000381629; expected ratio = 0.0001obtained abs = 8.3281e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.017598; expected ratio = 0.001obtained abs = 8.06512; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 420.64 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 499.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000386997; expected ratio = 0.0001obtained abs = 8.44503e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0178634; expected ratio = 0.001obtained abs = 8.2005; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 510.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000386327; expected ratio = 0.0001obtained abs = 8.43033e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018098; expected ratio = 0.001obtained abs = 8.30096; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000393324; expected ratio = 0.0001obtained abs = 8.58283e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0182944; expected ratio = 0.001obtained abs = 8.40466; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000392138; expected ratio = 0.0001obtained abs = 8.55692e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0184933; expected ratio = 0.001obtained abs = 8.48773; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 513.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000399129; expected ratio = 0.0001obtained abs = 8.70932e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0185979; expected ratio = 0.001obtained abs = 8.5492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 419.82 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00039718; expected ratio = 0.0001obtained abs = 8.66676e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187189; expected ratio = 0.001obtained abs = 8.59581; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 420.03 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 483.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000402926; expected ratio = 0.0001obtained abs = 8.79202e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187446; expected ratio = 0.001obtained abs = 8.62091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 2.048910e+05 Mflops = 412.96 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 499.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000400538; expected ratio = 0.0001obtained abs = 8.73989e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187909; expected ratio = 0.001obtained abs = 8.63271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.98642 - Final Residual ratio : 0.00176756 - Residual ratio : 0.000591864 - Slope : -0.0994884 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.66622 - Final Residual ratio : 0.00261715 - Residual ratio : 0.000981594 - Slope : -0.0918485 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.40178 - Final Residual ratio : 0.00176385 - Residual ratio : 0.000734392 - Slope : -0.085715 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.39295 - Final Residual ratio : 0.00161249 - Residual ratio : 0.000673851 - Slope : -0.0797111 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 2.9201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.55284 - Final Residual ratio : 0.00157266 - Residual ratio : 0.000616044 - Slope : -0.0850422 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.67951 - Final Residual ratio : 0.00156773 - Residual ratio : 0.000585083 - Slope : -0.0892646 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.63183 - Final Residual ratio : 0.00238952 - Residual ratio : 0.000907934 - Slope : -0.0906702 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.46388 - Final Residual ratio : 0.00189372 - Residual ratio : 0.00076859 - Slope : -0.0848962 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9241 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.30355 - Final Residual ratio : 0.00153529 - Residual ratio : 0.000666485 - Slope : -0.076734 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.21703 - Final Residual ratio : 0.00185316 - Residual ratio : 0.000835875 - Slope : -0.0763854 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9251 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 381.42 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 492.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0247295; expected ratio = 0.0001obtained abs = 0.000532591; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0496761; expected ratio = 0.001obtained abs = 22.5541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.72 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 506.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00446365; expected ratio = 0.0001obtained abs = 9.62063e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0503215; expected ratio = 0.001obtained abs = 22.9529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 385.98 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00146565; expected ratio = 0.0001obtained abs = 3.1584e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0327029; expected ratio = 0.001obtained abs = 14.9478; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 380.52 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 492.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000500408; expected ratio = 0.0001obtained abs = 1.07823e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0157753; expected ratio = 0.001obtained abs = 7.22196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.72 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 503.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000358866; expected ratio = 0.0001obtained abs = 7.73174e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118361; expected ratio = 0.001obtained abs = 5.43365; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 385.98 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 506.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000263229; expected ratio = 0.0001obtained abs = 5.67075e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00868823; expected ratio = 0.001obtained abs = 3.9916; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 385.98 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 506.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000218381; expected ratio = 0.0001obtained abs = 4.70429e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00920497; expected ratio = 0.001obtained abs = 4.23762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 377.67 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000280205; expected ratio = 0.0001obtained abs = 6.03577e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0127451; expected ratio = 0.001obtained abs = 5.8671; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 385.98 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 503.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000298733; expected ratio = 0.0001obtained abs = 6.43465e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142634; expected ratio = 0.001obtained abs = 6.57798; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.72 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 492.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000276633; expected ratio = 0.0001obtained abs = 5.95842e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0131426; expected ratio = 0.001obtained abs = 6.05853; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 385.98 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 506.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000265951; expected ratio = 0.0001obtained abs = 5.72823e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0133965; expected ratio = 0.001obtained abs = 6.18491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.72 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 492.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000270564; expected ratio = 0.0001obtained abs = 5.82744e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0134561; expected ratio = 0.001obtained abs = 6.20811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.72 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000306958; expected ratio = 0.0001obtained abs = 6.61124e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0149359; expected ratio = 0.001obtained abs = 6.90112; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.72 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00041575; expected ratio = 0.0001obtained abs = 8.95433e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187887; expected ratio = 0.001obtained abs = 8.67124; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 376.96 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000446478; expected ratio = 0.0001obtained abs = 9.61609e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0195071; expected ratio = 0.001obtained abs = 9.01762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.17 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000409418; expected ratio = 0.0001obtained abs = 8.81779e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0192594; expected ratio = 0.001obtained abs = 8.8919; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.72 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000416179; expected ratio = 0.0001obtained abs = 8.96341e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0189313; expected ratio = 0.001obtained abs = 8.75411; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.91 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000367147; expected ratio = 0.0001obtained abs = 7.90723e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170151; expected ratio = 0.001obtained abs = 7.85882; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.91 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000361051; expected ratio = 0.0001obtained abs = 7.77598e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0168884; expected ratio = 0.001obtained abs = 7.81164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.922410e+05 Mflops = 386.72 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 489.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00044657; expected ratio = 0.0001obtained abs = 9.61777e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.019515; expected ratio = 0.001obtained abs = 9.01453; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.17789 - Final Residual ratio : 0.00114071 - Residual ratio : 0.000523769 - Slope : -0.0725585 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.09253 - Final Residual ratio : 0.00107631 - Residual ratio : 0.000514361 - Slope : -0.069715 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.95068 - Final Residual ratio : 0.00181213 - Residual ratio : 0.000928972 - Slope : -0.0672024 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82959 - Final Residual ratio : 0.00167498 - Residual ratio : 0.000915496 - Slope : -0.0652827 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81352 - Final Residual ratio : 0.0017689 - Residual ratio : 0.000975396 - Slope : -0.0754897 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.88015 - Final Residual ratio : 0.00178671 - Residual ratio : 0.000950302 - Slope : -0.0647712 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.94971 - Final Residual ratio : 0.00168504 - Residual ratio : 0.000864252 - Slope : -0.0671732 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.95224 - Final Residual ratio : 0.00158976 - Residual ratio : 0.000814324 - Slope : -0.0672638 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.89194 - Final Residual ratio : 0.00146117 - Residual ratio : 0.000772313 - Slope : -0.065189 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81684 - Final Residual ratio : 0.00138338 - Residual ratio : 0.00076142 - Slope : -0.0605154 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 114 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9351 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.928290e+05 Mflops = 384.95 -Solve time = 0.00 -Solve flops = 1.717800e+04 Mflops = 490.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0251191; expected ratio = 0.0001obtained abs = 0.00053257; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0452151; expected ratio = 0.001obtained abs = 20.3954; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.941610e+05 Mflops = 390.59 -Solve time = 0.00 -Solve flops = 1.720600e+04 Mflops = 477.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00680914; expected ratio = 0.0001obtained abs = 0.000144781; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0367131; expected ratio = 0.001obtained abs = 16.5597; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.918870e+05 Mflops = 376.97 -Solve time = 0.00 -Solve flops = 1.713200e+04 Mflops = 475.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00124674; expected ratio = 0.0001obtained abs = 2.65039e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0252061; expected ratio = 0.001obtained abs = 11.3664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.94 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000562189; expected ratio = 0.0001obtained abs = 1.19519e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0195; expected ratio = 0.001obtained abs = 8.78346; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.20 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 506.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000489141; expected ratio = 0.0001obtained abs = 1.0399e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0172627; expected ratio = 0.001obtained abs = 7.78288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 389.70 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000438149; expected ratio = 0.0001obtained abs = 9.31513e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161142; expected ratio = 0.001obtained abs = 7.25636; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 405.96 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 521.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000427267; expected ratio = 0.0001obtained abs = 9.08363e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0159956; expected ratio = 0.001obtained abs = 7.21103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.94 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000421328; expected ratio = 0.0001obtained abs = 8.95748e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0157737; expected ratio = 0.001obtained abs = 7.10382; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.20 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000408541; expected ratio = 0.0001obtained abs = 8.68547e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161416; expected ratio = 0.001obtained abs = 7.27786; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.20 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00041239; expected ratio = 0.0001obtained abs = 8.76741e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0163174; expected ratio = 0.001obtained abs = 7.34955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 387.45 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000405079; expected ratio = 0.0001obtained abs = 8.61184e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0168322; expected ratio = 0.001obtained abs = 7.59061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.94 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 506.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000411525; expected ratio = 0.0001obtained abs = 8.74897e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0172862; expected ratio = 0.001obtained abs = 7.78661; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.94 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000413337; expected ratio = 0.0001obtained abs = 8.78739e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0178058; expected ratio = 0.001obtained abs = 8.03097; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.20 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000418767; expected ratio = 0.0001obtained abs = 8.90289e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0183672; expected ratio = 0.001obtained abs = 8.274; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.94 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000426958; expected ratio = 0.0001obtained abs = 9.07696e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187639; expected ratio = 0.001obtained abs = 8.46424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.20 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00042908; expected ratio = 0.0001obtained abs = 9.12212e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0192353; expected ratio = 0.001obtained abs = 8.66546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.20 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000438496; expected ratio = 0.0001obtained abs = 9.32224e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0194386; expected ratio = 0.001obtained abs = 8.76953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.94 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000437111; expected ratio = 0.0001obtained abs = 9.29285e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0197074; expected ratio = 0.001obtained abs = 8.87867; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.01 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000444002; expected ratio = 0.0001obtained abs = 9.43929e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0197394; expected ratio = 0.001obtained abs = 8.90594; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.925110e+05 Mflops = 388.20 -Solve time = 0.00 -Solve flops = 1.715600e+04 Mflops = 489.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000440748; expected ratio = 0.0001obtained abs = 9.37016e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0198214; expected ratio = 0.001obtained abs = 8.93068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7502 - Final Residual ratio : 0.00120218 - Residual ratio : 0.000686883 - Slope : -0.0624643 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70195 - Final Residual ratio : 0.0016036 - Residual ratio : 0.000942213 - Slope : -0.0607266 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64669 - Final Residual ratio : 0.00112137 - Residual ratio : 0.000680988 - Slope : -0.0567437 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57936 - Final Residual ratio : 0.00116626 - Residual ratio : 0.000738438 - Slope : -0.0544206 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52911 - Final Residual ratio : 0.00145043 - Residual ratio : 0.000948543 - Slope : -0.0545594 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50645 - Final Residual ratio : 0.00134771 - Residual ratio : 0.000894628 - Slope : -0.0557446 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52495 - Final Residual ratio : 0.00134097 - Residual ratio : 0.000879352 - Slope : -0.0525383 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.54932 - Final Residual ratio : 0.000958024 - Residual ratio : 0.00061835 - Slope : -0.0516122 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55069 - Final Residual ratio : 0.00146858 - Residual ratio : 0.00094705 - Slope : -0.0534213 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9451 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53077 - Final Residual ratio : 0.00131161 - Residual ratio : 0.000856833 - Slope : -0.0527398 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 124 - Mesh edges: 201 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9451 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.988150e+05 Mflops = 389.85 -Solve time = 0.00 -Solve flops = 1.780000e+04 Mflops = 494.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0237252; expected ratio = 0.0001obtained abs = 0.000493909; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0410909; expected ratio = 0.001obtained abs = 18.6806; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.988210e+05 Mflops = 396.91 -Solve time = 0.00 -Solve flops = 1.780000e+04 Mflops = 494.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00342911; expected ratio = 0.0001obtained abs = 7.13936e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0494711; expected ratio = 0.001obtained abs = 22.6825; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980770e+05 Mflops = 387.68 -Solve time = 0.00 -Solve flops = 1.778200e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00186092; expected ratio = 0.0001obtained abs = 3.87318e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.033241; expected ratio = 0.001obtained abs = 15.2958; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980770e+05 Mflops = 393.74 -Solve time = 0.00 -Solve flops = 1.778200e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000668278; expected ratio = 0.0001obtained abs = 1.39077e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018839; expected ratio = 0.001obtained abs = 8.67454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980770e+05 Mflops = 393.00 -Solve time = 0.00 -Solve flops = 1.778200e+04 Mflops = 507.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000381363; expected ratio = 0.0001obtained abs = 7.93588e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0153137; expected ratio = 0.001obtained abs = 7.06896; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980770e+05 Mflops = 393.74 -Solve time = 0.00 -Solve flops = 1.778200e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00030773; expected ratio = 0.0001obtained abs = 6.40336e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0131728; expected ratio = 0.001obtained abs = 6.08147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980770e+05 Mflops = 393.93 -Solve time = 0.00 -Solve flops = 1.778200e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000241; expected ratio = 0.0001obtained abs = 5.01452e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0128083; expected ratio = 0.001obtained abs = 5.92324; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980770e+05 Mflops = 394.49 -Solve time = 0.00 -Solve flops = 1.778200e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000228145; expected ratio = 0.0001obtained abs = 4.74697e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0131994; expected ratio = 0.001obtained abs = 6.10215; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980770e+05 Mflops = 394.49 -Solve time = 0.00 -Solve flops = 1.778200e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000231123; expected ratio = 0.0001obtained abs = 4.80874e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0169291; expected ratio = 0.001obtained abs = 7.83939; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.980770e+05 Mflops = 394.49 -Solve time = 0.00 -Solve flops = 1.778200e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000298895; expected ratio = 0.0001obtained abs = 6.21886e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0199866; expected ratio = 0.001obtained abs = 9.24554; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 393.42 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 507.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000291483; expected ratio = 0.0001obtained abs = 6.06445e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187773; expected ratio = 0.001obtained abs = 8.69969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 394.73 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 494.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000248455; expected ratio = 0.0001obtained abs = 5.16927e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0183081; expected ratio = 0.001obtained abs = 8.47377; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 382.56 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 497.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00024212; expected ratio = 0.0001obtained abs = 5.03732e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0221191; expected ratio = 0.001obtained abs = 10.2556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 393.23 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 511.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000305875; expected ratio = 0.0001obtained abs = 6.36386e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.019622; expected ratio = 0.001obtained abs = 9.08763; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 393.98 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 494.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000266547; expected ratio = 0.0001obtained abs = 5.54544e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0130465; expected ratio = 0.001obtained abs = 6.04777; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 393.98 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 494.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000222895; expected ratio = 0.0001obtained abs = 4.63736e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00620504; expected ratio = 0.001obtained abs = 2.8764; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 394.73 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 494.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000260591; expected ratio = 0.0001obtained abs = 5.42143e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00884357; expected ratio = 0.001obtained abs = 4.09884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 394.73 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 494.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000306779; expected ratio = 0.0001obtained abs = 6.3826e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0101051; expected ratio = 0.001obtained abs = 4.68355; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 393.98 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 494.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000283906; expected ratio = 0.0001obtained abs = 5.90653e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00859197; expected ratio = 0.001obtained abs = 3.98341; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.981970e+05 Mflops = 384.86 -Solve time = 0.00 -Solve flops = 1.778800e+04 Mflops = 494.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000219333; expected ratio = 0.0001obtained abs = 4.56322e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00636453; expected ratio = 0.001obtained abs = 2.95049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48228 - Final Residual ratio : 0.000950565 - Residual ratio : 0.000641287 - Slope : -0.0592531 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43881 - Final Residual ratio : 0.000871392 - Residual ratio : 0.000605635 - Slope : -0.0575174 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40124 - Final Residual ratio : 0.00101239 - Residual ratio : 0.000722495 - Slope : -0.050008 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36273 - Final Residual ratio : 0.00102548 - Residual ratio : 0.000752522 - Slope : -0.0486321 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33182 - Final Residual ratio : 0.00102151 - Residual ratio : 0.000767001 - Slope : -0.0475286 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29265 - Final Residual ratio : 0.00103342 - Residual ratio : 0.000799453 - Slope : -0.0461293 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27635 - Final Residual ratio : 0.0011772 - Residual ratio : 0.000922317 - Slope : -0.0490452 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27535 - Final Residual ratio : 0.00123597 - Residual ratio : 0.000969118 - Slope : -0.0455042 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27775 - Final Residual ratio : 0.00127235 - Residual ratio : 0.000995771 - Slope : -0.0490955 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.28335 - Final Residual ratio : 0.00119285 - Residual ratio : 0.00092948 - Slope : -0.0442124 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 124 - Mesh edges: 201 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9551 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.958350e+05 Mflops = 376.61 -Solve time = 0.00 -Solve flops = 1.768600e+04 Mflops = 491.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0267156; expected ratio = 0.0001obtained abs = 0.000546341; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0649415; expected ratio = 0.001obtained abs = 29.2022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.964530e+05 Mflops = 391.44 -Solve time = 0.00 -Solve flops = 1.769800e+04 Mflops = 491.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00824494; expected ratio = 0.0001obtained abs = 0.000169201; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.058501; expected ratio = 0.001obtained abs = 26.2931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.49 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 509.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00192745; expected ratio = 0.0001obtained abs = 3.95363e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0416505; expected ratio = 0.001obtained abs = 18.8601; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.49 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000752828; expected ratio = 0.0001obtained abs = 1.54416e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0270091; expected ratio = 0.001obtained abs = 12.2288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.68 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000452638; expected ratio = 0.0001obtained abs = 9.28357e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0245292; expected ratio = 0.001obtained abs = 11.1416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.68 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 505.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000330505; expected ratio = 0.0001obtained abs = 6.77852e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0218174; expected ratio = 0.001obtained abs = 9.89709; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 391.75 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000299025; expected ratio = 0.0001obtained abs = 6.13264e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0321516; expected ratio = 0.001obtained abs = 14.6225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 393.42 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000272006; expected ratio = 0.0001obtained abs = 5.57854e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0472713; expected ratio = 0.001obtained abs = 21.4333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.68 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 505.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000241051; expected ratio = 0.0001obtained abs = 4.94359e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0398924; expected ratio = 0.001obtained abs = 18.1295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 385.53 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000265861; expected ratio = 0.0001obtained abs = 5.45248e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0298558; expected ratio = 0.001obtained abs = 13.5356; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.960330e+05 Mflops = 390.60 -Solve time = 0.00 -Solve flops = 1.767400e+04 Mflops = 504.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000261237; expected ratio = 0.0001obtained abs = 5.35762e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0358211; expected ratio = 0.001obtained abs = 16.2764; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.49 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000222618; expected ratio = 0.0001obtained abs = 4.56568e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0799362; expected ratio = 0.001obtained abs = 36.1797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.49 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000475245; expected ratio = 0.0001obtained abs = 9.74691e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0627052; expected ratio = 0.001obtained abs = 28.4731; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 391.19 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 505.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000623742; expected ratio = 0.0001obtained abs = 1.27912e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0457855; expected ratio = 0.001obtained abs = 20.7198; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.960330e+05 Mflops = 390.60 -Solve time = 0.00 -Solve flops = 1.767400e+04 Mflops = 490.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000491749; expected ratio = 0.0001obtained abs = 1.00855e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.052436; expected ratio = 0.001obtained abs = 23.7853; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.68 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 505.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000339535; expected ratio = 0.0001obtained abs = 6.96374e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0297241; expected ratio = 0.001obtained abs = 13.4476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.49 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000280759; expected ratio = 0.0001obtained abs = 5.75833e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.031581; expected ratio = 0.001obtained abs = 14.3157; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 391.93 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 505.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000235042; expected ratio = 0.0001obtained abs = 4.82071e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0350281; expected ratio = 0.001obtained abs = 15.8358; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 392.68 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000187725; expected ratio = 0.0001obtained abs = 3.85026e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0530463; expected ratio = 0.001obtained abs = 24.0683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.970730e+05 Mflops = 393.24 -Solve time = 0.00 -Solve flops = 1.772600e+04 Mflops = 492.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000176424; expected ratio = 0.0001obtained abs = 3.61852e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.148846; expected ratio = 0.001obtained abs = 67.3182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2583 - Final Residual ratio : 0.0010139 - Residual ratio : 0.000805768 - Slope : -0.052387 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.23205 - Final Residual ratio : 0.00122308 - Residual ratio : 0.000992724 - Slope : -0.0615412 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.20361 - Final Residual ratio : 0.0011806 - Residual ratio : 0.000980886 - Slope : -0.0462472 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17658 - Final Residual ratio : 0.00092426 - Residual ratio : 0.000785547 - Slope : -0.0435429 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15932 - Final Residual ratio : 0.000691597 - Residual ratio : 0.000596556 - Slope : -0.0413795 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12464 - Final Residual ratio : 0.0007214 - Residual ratio : 0.000641452 - Slope : -0.0401398 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10326 - Final Residual ratio : 0.000956507 - Residual ratio : 0.00086698 - Slope : -0.0408262 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0896 - Final Residual ratio : 0.000972259 - Residual ratio : 0.000892306 - Slope : -0.0418704 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08219 - Final Residual ratio : 0.000917684 - Residual ratio : 0.000847991 - Slope : -0.0386167 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08733 - Final Residual ratio : 0.00108438 - Residual ratio : 0.000997289 - Slope : -0.0472281 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 124 - Mesh edges: 201 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9651 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.804840e+05 Mflops = 361.68 -Solve time = 0.00 -Solve flops = 1.715000e+04 Mflops = 492.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0345656; expected ratio = 0.0001obtained abs = 0.000694754; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.359465; expected ratio = 0.001obtained abs = 147.032; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.820920e+05 Mflops = 360.43 -Solve time = 0.00 -Solve flops = 1.723000e+04 Mflops = 494.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0177327; expected ratio = 0.0001obtained abs = 0.000358356; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170587; expected ratio = 0.001obtained abs = 64.792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.853700e+05 Mflops = 363.32 -Solve time = 0.00 -Solve flops = 1.738800e+04 Mflops = 499.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00786717; expected ratio = 0.0001obtained abs = 0.000159616; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0697012; expected ratio = 0.001obtained abs = 25.5615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.848660e+05 Mflops = 366.79 -Solve time = 0.00 -Solve flops = 1.735600e+04 Mflops = 495.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00488693; expected ratio = 0.0001obtained abs = 9.93064e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0429741; expected ratio = 0.001obtained abs = 15.4287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.850340e+05 Mflops = 369.39 -Solve time = 0.00 -Solve flops = 1.736000e+04 Mflops = 495.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00269053; expected ratio = 0.0001obtained abs = 5.47295e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0334611; expected ratio = 0.001obtained abs = 11.8668; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 367.53 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 508.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00178779; expected ratio = 0.0001obtained abs = 3.63925e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0259891; expected ratio = 0.001obtained abs = 9.13111; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.851420e+05 Mflops = 368.73 -Solve time = 0.00 -Solve flops = 1.737000e+04 Mflops = 495.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0013027; expected ratio = 0.0001obtained abs = 2.65292e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0239729; expected ratio = 0.001obtained abs = 8.38343; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 367.53 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 508.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000853749; expected ratio = 0.0001obtained abs = 1.73918e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0117688; expected ratio = 0.001obtained abs = 4.09872; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 367.53 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 494.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000677252; expected ratio = 0.0001obtained abs = 1.3799e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187836; expected ratio = 0.001obtained abs = 6.51702; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.853760e+05 Mflops = 369.19 -Solve time = 0.00 -Solve flops = 1.738400e+04 Mflops = 496.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000442183; expected ratio = 0.0001obtained abs = 9.01082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.012776; expected ratio = 0.001obtained abs = 4.42749; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 367.35 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 498.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000347433; expected ratio = 0.0001obtained abs = 7.0807e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0448923; expected ratio = 0.001obtained abs = 15.5096; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.867700e+05 Mflops = 372.15 -Solve time = 0.00 -Solve flops = 1.744600e+04 Mflops = 497.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000682474; expected ratio = 0.0001obtained abs = 1.39097e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0459827; expected ratio = 0.001obtained abs = 15.8951; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.859100e+05 Mflops = 368.86 -Solve time = 0.00 -Solve flops = 1.740200e+04 Mflops = 496.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000596143; expected ratio = 0.0001obtained abs = 1.21513e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0149927; expected ratio = 0.001obtained abs = 5.17531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.851420e+05 Mflops = 368.90 -Solve time = 0.00 -Solve flops = 1.737000e+04 Mflops = 509.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000426124; expected ratio = 0.0001obtained abs = 8.6858e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0163164; expected ratio = 0.001obtained abs = 5.63712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 367.35 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 494.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000334596; expected ratio = 0.0001obtained abs = 6.82033e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.016535; expected ratio = 0.001obtained abs = 5.70379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 367.53 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 494.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000352122; expected ratio = 0.0001obtained abs = 7.17757e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0151101; expected ratio = 0.001obtained abs = 5.21804; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 367.53 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 494.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000313861; expected ratio = 0.0001obtained abs = 6.3978e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0153065; expected ratio = 0.001obtained abs = 5.2789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 367.53 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 494.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000350836; expected ratio = 0.0001obtained abs = 7.15144e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0130362; expected ratio = 0.001obtained abs = 4.49971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 358.83 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 494.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00034075; expected ratio = 0.0001obtained abs = 6.94604e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0124095; expected ratio = 0.001obtained abs = 4.27933; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.844520e+05 Mflops = 367.35 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 494.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000367598; expected ratio = 0.0001obtained abs = 7.49315e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118982; expected ratio = 0.001obtained abs = 4.10636; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9661 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06904 - Final Residual ratio : 0.00100651 - Residual ratio : 0.000941507 - Slope : -0.0368287 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05605 - Final Residual ratio : 0.00105157 - Residual ratio : 0.000995754 - Slope : -0.040577 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04009 - Final Residual ratio : 0.0009769 - Residual ratio : 0.000939242 - Slope : -0.0384858 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02267 - Final Residual ratio : 0.000877806 - Residual ratio : 0.000858344 - Slope : -0.0364927 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01377 - Final Residual ratio : 0.00058198 - Residual ratio : 0.000574072 - Slope : -0.0405277 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.985 - Final Residual ratio : 0.000741604 - Residual ratio : 0.000752897 - Slope : -0.0393703 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.967045 - Final Residual ratio : 0.00079724 - Residual ratio : 0.000824409 - Slope : -0.0386499 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.952288 - Final Residual ratio : 0.000637075 - Residual ratio : 0.000668994 - Slope : -0.038066 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.940699 - Final Residual ratio : 0.000842488 - Residual ratio : 0.000895597 - Slope : -0.0348095 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.942417 - Final Residual ratio : 0.00094215 - Residual ratio : 0.000999716 - Slope : -0.0336241 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 124 - Mesh edges: 201 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9751 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.780990e+05 Mflops = 350.54 -Solve time = 0.00 -Solve flops = 1.704800e+04 Mflops = 486.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0336196; expected ratio = 0.0001obtained abs = 0.000684387; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.152687; expected ratio = 0.001obtained abs = 57.0495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.758350e+05 Mflops = 351.70 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 496.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0178332; expected ratio = 0.0001obtained abs = 0.000360664; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0930689; expected ratio = 0.001obtained abs = 36.1601; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.752430e+05 Mflops = 347.69 -Solve time = 0.00 -Solve flops = 1.688600e+04 Mflops = 498.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00763347; expected ratio = 0.0001obtained abs = 0.000153995; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0701466; expected ratio = 0.001obtained abs = 28.0808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.757310e+05 Mflops = 346.69 -Solve time = 0.00 -Solve flops = 1.691000e+04 Mflops = 495.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00416339; expected ratio = 0.0001obtained abs = 8.38254e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0424012; expected ratio = 0.001obtained abs = 17.2633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.753310e+05 Mflops = 349.19 -Solve time = 0.00 -Solve flops = 1.688800e+04 Mflops = 498.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0028828; expected ratio = 0.0001obtained abs = 5.79621e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0387934; expected ratio = 0.001obtained abs = 16.0547; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.754570e+05 Mflops = 349.61 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 482.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00216092; expected ratio = 0.0001obtained abs = 4.34033e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0294054; expected ratio = 0.001obtained abs = 12.3194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 345.13 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 483.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0016605; expected ratio = 0.0001obtained abs = 3.33263e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172451; expected ratio = 0.001obtained abs = 74.6997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 351.19 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 486.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00125915; expected ratio = 0.0001obtained abs = 2.52571e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.482432; expected ratio = 0.001obtained abs = 210.032; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 351.36 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 483.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00100021; expected ratio = 0.0001obtained abs = 2.00546e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.378796; expected ratio = 0.001obtained abs = 162.501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 350.53 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 483.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000770593; expected ratio = 0.0001obtained abs = 1.54451e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.262978; expected ratio = 0.001obtained abs = 113.12; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 350.53 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 483.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0006514; expected ratio = 0.0001obtained abs = 1.30529e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.304831; expected ratio = 0.001obtained abs = 132.357; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 351.19 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 486.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000479544; expected ratio = 0.0001obtained abs = 9.60706e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.293117; expected ratio = 0.001obtained abs = 126.317; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 350.53 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 486.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000421468; expected ratio = 0.0001obtained abs = 8.4424e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.257542; expected ratio = 0.001obtained abs = 111.748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 350.69 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 483.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000336871; expected ratio = 0.0001obtained abs = 6.74687e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.241811; expected ratio = 0.001obtained abs = 104.589; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 342.41 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 500.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000302894; expected ratio = 0.0001obtained abs = 6.06594e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.292558; expected ratio = 0.001obtained abs = 128.037; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 350.53 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 483.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000200706; expected ratio = 0.0001obtained abs = 4.01906e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249146; expected ratio = 0.001obtained abs = 107.42; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 350.53 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 483.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000207686; expected ratio = 0.0001obtained abs = 4.15867e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.199549; expected ratio = 0.001obtained abs = 86.8107; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 349.86 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 496.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000146083; expected ratio = 0.0001obtained abs = 2.92495e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.180994; expected ratio = 0.001obtained abs = 78.041; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.769970e+05 Mflops = 348.53 -Solve time = 0.00 -Solve flops = 1.696800e+04 Mflops = 497.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000153735; expected ratio = 0.0001obtained abs = 3.07812e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.171458; expected ratio = 0.001obtained abs = 74.5733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763370e+05 Mflops = 350.53 -Solve time = 0.00 -Solve flops = 1.693800e+04 Mflops = 496.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000116295; expected ratio = 0.0001obtained abs = 2.32837e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.161013; expected ratio = 0.001obtained abs = 69.4425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.89408 - Final Residual ratio : 0.00140019 - Residual ratio : 0.000739245 - Slope : -0.0727952 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77644 - Final Residual ratio : 0.00173403 - Residual ratio : 0.000976128 - Slope : -0.0657298 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.92732 - Final Residual ratio : 0.00174067 - Residual ratio : 0.000903157 - Slope : -0.0802326 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.88603 - Final Residual ratio : 0.00158596 - Residual ratio : 0.000840899 - Slope : -0.0649808 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.73702 - Final Residual ratio : 0.00169477 - Residual ratio : 0.000975678 - Slope : -0.0642714 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55095 - Final Residual ratio : 0.00149559 - Residual ratio : 0.000964302 - Slope : -0.0704299 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40352 - Final Residual ratio : 0.0006918 - Residual ratio : 0.000492902 - Slope : -0.0561133 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30887 - Final Residual ratio : 0.00116203 - Residual ratio : 0.000887807 - Slope : -0.0484337 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24618 - Final Residual ratio : 0.00123022 - Residual ratio : 0.000987197 - Slope : -0.0444624 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19815 - Final Residual ratio : 0.00106873 - Residual ratio : 0.000891985 - Slope : -0.0412788 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 124 - Mesh edges: 201 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9851 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.755530e+05 Mflops = 346.34 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 480.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0456417; expected ratio = 0.0001obtained abs = 0.000883434; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.227768; expected ratio = 0.001obtained abs = 87.4824; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.781670e+05 Mflops = 352.16 -Solve time = 0.00 -Solve flops = 1.699000e+04 Mflops = 498.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0257629; expected ratio = 0.0001obtained abs = 0.000504794; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0943829; expected ratio = 0.001obtained abs = 34.7176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.792170e+05 Mflops = 354.91 -Solve time = 0.00 -Solve flops = 1.704000e+04 Mflops = 499.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00362327; expected ratio = 0.0001obtained abs = 7.09227e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0443955; expected ratio = 0.001obtained abs = 16.415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.814510e+05 Mflops = 357.98 -Solve time = 0.00 -Solve flops = 1.713800e+04 Mflops = 488.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00131018; expected ratio = 0.0001obtained abs = 2.56479e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0332988; expected ratio = 0.001obtained abs = 12.2218; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.809050e+05 Mflops = 358.25 -Solve time = 0.00 -Solve flops = 1.712000e+04 Mflops = 488.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000794108; expected ratio = 0.0001obtained abs = 1.55483e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0331224; expected ratio = 0.001obtained abs = 12.1832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.801070e+05 Mflops = 356.67 -Solve time = 0.00 -Solve flops = 1.708200e+04 Mflops = 487.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00038468; expected ratio = 0.0001obtained abs = 7.53251e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0499858; expected ratio = 0.001obtained abs = 18.3579; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.789570e+05 Mflops = 355.73 -Solve time = 0.00 -Solve flops = 1.703200e+04 Mflops = 503.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000312041; expected ratio = 0.0001obtained abs = 6.11077e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134805; expected ratio = 0.001obtained abs = 49.5789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.808670e+05 Mflops = 358.17 -Solve time = 0.00 -Solve flops = 1.712000e+04 Mflops = 488.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00023684; expected ratio = 0.0001obtained abs = 4.63838e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166279; expected ratio = 0.001obtained abs = 61.6937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.803010e+05 Mflops = 358.41 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 490.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000238553; expected ratio = 0.0001obtained abs = 4.67215e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.294201; expected ratio = 0.001obtained abs = 109.041; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.803010e+05 Mflops = 356.88 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 504.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000183728; expected ratio = 0.0001obtained abs = 3.59858e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.326971; expected ratio = 0.001obtained abs = 121.044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.803010e+05 Mflops = 355.04 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000128105; expected ratio = 0.0001obtained abs = 2.50921e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.206918; expected ratio = 0.001obtained abs = 75.39; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.803010e+05 Mflops = 356.38 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000115155; expected ratio = 0.0001obtained abs = 2.25562e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0881982; expected ratio = 0.001obtained abs = 32.2467; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.803010e+05 Mflops = 358.58 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 501.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.83848e-05; expected ratio = 0.0001obtained abs = 1.53541e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0743003; expected ratio = 0.001obtained abs = 27.031; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1391 - Final Residual ratio : 0.00105478 - Residual ratio : 0.000925972 - Slope : -0.04215 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09328 - Final Residual ratio : 0.000937074 - Residual ratio : 0.00085712 - Slope : -0.0390123 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9881 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06042 - Final Residual ratio : 0.000892143 - Residual ratio : 0.000841314 - Slope : -0.0365353 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03905 - Final Residual ratio : 0.000987458 - Residual ratio : 0.000950346 - Slope : -0.0610625 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03088 - Final Residual ratio : 0.000918177 - Residual ratio : 0.000890673 - Slope : -0.0367844 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.99996 - Final Residual ratio : 0.000899872 - Residual ratio : 0.000899908 - Slope : -0.0356807 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.975616 - Final Residual ratio : 0.000957097 - Residual ratio : 0.000981019 - Slope : -0.0512978 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.951718 - Final Residual ratio : 0.00086763 - Residual ratio : 0.000911646 - Slope : -0.033959 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.928246 - Final Residual ratio : 0.000716509 - Residual ratio : 0.000771895 - Slope : -0.0371012 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9951 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.918713 - Final Residual ratio : 0.00079732 - Residual ratio : 0.000867866 - Slope : -0.0353044 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 2.9951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 13 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 124 - Mesh edges: 201 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 2.9951 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.803010e+05 Mflops = 355.71 -Solve time = 0.00 -Solve flops = 1.708800e+04 Mflops = 487.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0307703; expected ratio = 0.0001obtained abs = 0.000593262; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146131; expected ratio = 0.001obtained abs = 57.656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.753630e+05 Mflops = 349.42 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 494.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0168543; expected ratio = 0.0001obtained abs = 0.000323848; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.156663; expected ratio = 0.001obtained abs = 61.9189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.760710e+05 Mflops = 349.50 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 495.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00503935; expected ratio = 0.0001obtained abs = 9.67373e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103256; expected ratio = 0.001obtained abs = 41.4361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.769510e+05 Mflops = 350.42 -Solve time = 0.00 -Solve flops = 1.693400e+04 Mflops = 496.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00191855; expected ratio = 0.0001obtained abs = 3.68122e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0885453; expected ratio = 0.001obtained abs = 35.7345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.776330e+05 Mflops = 351.11 -Solve time = 0.00 -Solve flops = 1.696400e+04 Mflops = 497.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00131581; expected ratio = 0.0001obtained abs = 2.52353e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123079; expected ratio = 0.001obtained abs = 50.0602; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.763950e+05 Mflops = 350.14 -Solve time = 0.00 -Solve flops = 1.691400e+04 Mflops = 496.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000993865; expected ratio = 0.0001obtained abs = 1.90547e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.114281; expected ratio = 0.001obtained abs = 46.7742; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.787450e+05 Mflops = 353.97 -Solve time = 0.00 -Solve flops = 1.701400e+04 Mflops = 485.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000805813; expected ratio = 0.0001obtained abs = 1.54444e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.268437; expected ratio = 0.001obtained abs = 111.739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.809950e+05 Mflops = 355.57 -Solve time = 0.00 -Solve flops = 1.711400e+04 Mflops = 488.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000609522; expected ratio = 0.0001obtained abs = 1.16795e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.259723; expected ratio = 0.001obtained abs = 106.302; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.746350e+05 Mflops = 347.14 -Solve time = 0.00 -Solve flops = 1.682600e+04 Mflops = 483.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00049831; expected ratio = 0.0001obtained abs = 9.54648e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.135234; expected ratio = 0.001obtained abs = 55.5471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.796570e+05 Mflops = 354.27 -Solve time = 0.00 -Solve flops = 1.705800e+04 Mflops = 503.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000398768; expected ratio = 0.0001obtained abs = 7.6383e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0966411; expected ratio = 0.001obtained abs = 39.7464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.765270e+05 Mflops = 350.90 -Solve time = 0.00 -Solve flops = 1.691400e+04 Mflops = 499.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000280314; expected ratio = 0.0001obtained abs = 5.36863e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0867971; expected ratio = 0.001obtained abs = 35.7118; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.796570e+05 Mflops = 354.27 -Solve time = 0.00 -Solve flops = 1.705800e+04 Mflops = 486.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000231628; expected ratio = 0.0001obtained abs = 4.4358e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0682436; expected ratio = 0.001obtained abs = 28.1646; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.774070e+05 Mflops = 351.99 -Solve time = 0.00 -Solve flops = 1.695800e+04 Mflops = 497.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000159012; expected ratio = 0.0001obtained abs = 3.04494e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0599598; expected ratio = 0.001obtained abs = 24.7016; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.774070e+05 Mflops = 343.22 -Solve time = 0.00 -Solve flops = 1.695800e+04 Mflops = 497.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000133093; expected ratio = 0.0001obtained abs = 2.54848e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.053995; expected ratio = 0.001obtained abs = 22.3148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.805370e+05 Mflops = 356.17 -Solve time = 0.00 -Solve flops = 1.710200e+04 Mflops = 487.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.821e-05; expected ratio = 0.0001obtained abs = 1.68899e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0467464; expected ratio = 0.001obtained abs = 19.2758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 2.9961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75521 - Final Residual ratio : 0.00143437 - Residual ratio : 0.000817205 - Slope : -0.060475 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.75013 - Final Residual ratio : 0.00202332 - Residual ratio : 0.000735719 - Slope : -0.0981466 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.09449 - Final Residual ratio : 0.00286938 - Residual ratio : 0.000927254 - Slope : -0.114505 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 2.9991 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.93955 - Final Residual ratio : 0.00253989 - Residual ratio : 0.00086404 - Slope : -0.108778 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 2.9991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.59127 - Final Residual ratio : 0.00247518 - Residual ratio : 0.000955202 - Slope : -0.0924569 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.20442 - Final Residual ratio : 0.00181265 - Residual ratio : 0.000822278 - Slope : -0.0786647 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.9233 - Final Residual ratio : 0.00116517 - Residual ratio : 0.000605817 - Slope : -0.0640712 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.72428 - Final Residual ratio : 0.00116187 - Residual ratio : 0.000673832 - Slope : -0.0574373 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.54988 - Final Residual ratio : 0.000974199 - Residual ratio : 0.000628563 - Slope : -0.0516303 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.39619 - Final Residual ratio : 0.00137148 - Residual ratio : 0.000982301 - Slope : -0.0480971 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 15 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 124 - Mesh edges: 201 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0051 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.795410e+05 Mflops = 350.75 -Solve time = 0.00 -Solve flops = 1.704800e+04 Mflops = 436.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0387898; expected ratio = 0.0001obtained abs = 0.000720185; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146842; expected ratio = 0.001obtained abs = 56.5595; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.761010e+05 Mflops = 345.31 -Solve time = 0.00 -Solve flops = 1.688600e+04 Mflops = 481.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0183939; expected ratio = 0.0001obtained abs = 0.000344529; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145907; expected ratio = 0.001obtained abs = 54.0032; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.767910e+05 Mflops = 352.26 -Solve time = 0.00 -Solve flops = 1.691600e+04 Mflops = 482.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00318553; expected ratio = 0.0001obtained abs = 5.96162e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0765887; expected ratio = 0.001obtained abs = 28.6354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.796050e+05 Mflops = 374.04 -Solve time = 0.00 -Solve flops = 1.702800e+04 Mflops = 517.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000890621; expected ratio = 0.0001obtained abs = 1.66678e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0786735; expected ratio = 0.001obtained abs = 29.3042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.789530e+05 Mflops = 355.05 -Solve time = 0.00 -Solve flops = 1.701000e+04 Mflops = 485.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000577053; expected ratio = 0.0001obtained abs = 1.08006e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.311001; expected ratio = 0.001obtained abs = 119.413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.787390e+05 Mflops = 355.47 -Solve time = 0.00 -Solve flops = 1.700400e+04 Mflops = 498.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000291041; expected ratio = 0.0001obtained abs = 5.44757e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.344736; expected ratio = 0.001obtained abs = 128.661; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.783490e+05 Mflops = 346.96 -Solve time = 0.00 -Solve flops = 1.699200e+04 Mflops = 501.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000228539; expected ratio = 0.0001obtained abs = 4.2779e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.204454; expected ratio = 0.001obtained abs = 76.4171; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.767910e+05 Mflops = 352.26 -Solve time = 0.00 -Solve flops = 1.691600e+04 Mflops = 496.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00020463; expected ratio = 0.0001obtained abs = 3.83052e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.135499; expected ratio = 0.001obtained abs = 50.2501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.778030e+05 Mflops = 352.77 -Solve time = 0.00 -Solve flops = 1.696000e+04 Mflops = 497.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00018246; expected ratio = 0.0001obtained abs = 3.41563e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.088805; expected ratio = 0.001obtained abs = 32.9342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.767910e+05 Mflops = 352.93 -Solve time = 0.00 -Solve flops = 1.691600e+04 Mflops = 496.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.84199e-05; expected ratio = 0.0001obtained abs = 1.84247e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0533837; expected ratio = 0.001obtained abs = 19.7606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2721 - Final Residual ratio : 0.00124089 - Residual ratio : 0.000975467 - Slope : -0.0453877 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24393 - Final Residual ratio : 0.000847439 - Residual ratio : 0.000681258 - Slope : -0.0414362 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26812 - Final Residual ratio : 0.000640657 - Residual ratio : 0.0005052 - Slope : -0.0422495 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2763 - Final Residual ratio : 0.000608743 - Residual ratio : 0.000476957 - Slope : -0.0425232 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27293 - Final Residual ratio : 0.000672018 - Residual ratio : 0.000527932 - Slope : -0.0424085 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17072 - Final Residual ratio : 0.00112412 - Residual ratio : 0.000960196 - Slope : -0.0403309 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10593 - Final Residual ratio : 0.00100151 - Residual ratio : 0.000905577 - Slope : -0.0424974 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06762 - Final Residual ratio : 0.00104925 - Residual ratio : 0.000982793 - Slope : -0.0380919 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03869 - Final Residual ratio : 0.000571446 - Residual ratio : 0.00055016 - Slope : -0.0357972 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02244 - Final Residual ratio : 0.000808954 - Residual ratio : 0.000791196 - Slope : -0.0352288 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 124 - Mesh edges: 201 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0151 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.789090e+05 Mflops = 354.30 -Solve time = 0.00 -Solve flops = 1.702200e+04 Mflops = 485.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0296535; expected ratio = 0.0001obtained abs = 0.000544331; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119002; expected ratio = 0.001obtained abs = 46.2427; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.774470e+05 Mflops = 352.07 -Solve time = 0.00 -Solve flops = 1.696800e+04 Mflops = 484.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0131629; expected ratio = 0.0001obtained abs = 0.000241089; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159384; expected ratio = 0.001obtained abs = 61.5182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.741690e+05 Mflops = 347.04 -Solve time = 0.00 -Solve flops = 1.680200e+04 Mflops = 492.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00428996; expected ratio = 0.0001obtained abs = 7.85316e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0919094; expected ratio = 0.001obtained abs = 35.8117; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.749250e+05 Mflops = 348.55 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 480.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00142128; expected ratio = 0.0001obtained abs = 2.60127e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.20154; expected ratio = 0.001obtained abs = 80.3682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.778850e+05 Mflops = 351.60 -Solve time = 0.00 -Solve flops = 1.696600e+04 Mflops = 497.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000879085; expected ratio = 0.0001obtained abs = 1.60857e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.526469; expected ratio = 0.001obtained abs = 219.055; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.776190e+05 Mflops = 352.41 -Solve time = 0.00 -Solve flops = 1.695200e+04 Mflops = 500.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000742175; expected ratio = 0.0001obtained abs = 1.35781e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.422252; expected ratio = 0.001obtained abs = 166.019; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.754010e+05 Mflops = 348.83 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000634092; expected ratio = 0.0001obtained abs = 1.15986e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.13273; expected ratio = 0.001obtained abs = 52.963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000659943 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.762810e+05 Mflops = 350.42 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 485.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000489289; expected ratio = 0.0001obtained abs = 8.94852e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19022; expected ratio = 0.001obtained abs = 74.6664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.765510e+05 Mflops = 352.46 -Solve time = 0.00 -Solve flops = 1.690200e+04 Mflops = 495.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000368692; expected ratio = 0.0001obtained abs = 6.74214e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129475; expected ratio = 0.001obtained abs = 51.2815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.762810e+05 Mflops = 351.92 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 495.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000301687; expected ratio = 0.0001obtained abs = 5.51615e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0738205; expected ratio = 0.001obtained abs = 29.157; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.754010e+05 Mflops = 350.83 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 480.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000251718; expected ratio = 0.0001obtained abs = 4.6021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0802423; expected ratio = 0.001obtained abs = 31.8442; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.762810e+05 Mflops = 351.08 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 499.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000177751; expected ratio = 0.0001obtained abs = 3.24955e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0664122; expected ratio = 0.001obtained abs = 26.2801; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.765510e+05 Mflops = 350.29 -Solve time = 0.00 -Solve flops = 1.690200e+04 Mflops = 482.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000143084; expected ratio = 0.0001obtained abs = 2.61567e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0575094; expected ratio = 0.001obtained abs = 22.8404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.762810e+05 Mflops = 351.08 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 495.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.69202e-05; expected ratio = 0.0001obtained abs = 1.77169e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0476063; expected ratio = 0.001obtained abs = 18.8647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.51538 - Final Residual ratio : 0.00734168 - Residual ratio : 0.000862167 - Slope : -0.340322 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.58409 - Final Residual ratio : 0.00637277 - Residual ratio : 0.000967904 - Slope : -0.285988 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.11142 - Final Residual ratio : 0.00664842 - Residual ratio : 0.000934893 - Slope : -0.27326 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.62962 - Final Residual ratio : 0.00601197 - Residual ratio : 0.000906834 - Slope : -0.245319 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.95332 - Final Residual ratio : 0.0057178 - Residual ratio : 0.000960438 - Slope : -0.220282 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.0211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.18913 - Final Residual ratio : 0.00436639 - Residual ratio : 0.000841449 - Slope : -0.192028 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.60003 - Final Residual ratio : 0.00441338 - Residual ratio : 0.000959425 - Slope : -0.218839 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.15465 - Final Residual ratio : 0.00380515 - Residual ratio : 0.000915878 - Slope : -0.259428 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.82288 - Final Residual ratio : 0.00350235 - Residual ratio : 0.000916153 - Slope : -0.159141 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.62791 - Final Residual ratio : 0.00343845 - Residual ratio : 0.000947776 - Slope : -0.144979 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 14 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 124 - Mesh edges: 201 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0251 -matrix_partition : [5](0,49,98,147,198) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.827640e+05 Mflops = 352.28 -Solve time = 0.00 -Solve flops = 1.722600e+04 Mflops = 478.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0366112; expected ratio = 0.0001obtained abs = 0.000649802; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.13437; expected ratio = 0.001obtained abs = 50.8391; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.846700e+05 Mflops = 357.93 -Solve time = 0.00 -Solve flops = 1.732200e+04 Mflops = 481.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.013862; expected ratio = 0.0001obtained abs = 0.000247814; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.153368; expected ratio = 0.001obtained abs = 55.4926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.838600e+05 Mflops = 357.02 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 480.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00240615; expected ratio = 0.0001obtained abs = 4.30088e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0775045; expected ratio = 0.001obtained abs = 28.1219; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.829800e+05 Mflops = 355.97 -Solve time = 0.00 -Solve flops = 1.724800e+04 Mflops = 492.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000985441; expected ratio = 0.0001obtained abs = 1.76212e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0692366; expected ratio = 0.001obtained abs = 24.9076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.859640e+05 Mflops = 359.77 -Solve time = 0.00 -Solve flops = 1.738600e+04 Mflops = 470.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000680963; expected ratio = 0.0001obtained abs = 1.21795e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.206929; expected ratio = 0.001obtained abs = 75.4483; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.860840e+05 Mflops = 360.01 -Solve time = 0.00 -Solve flops = 1.739200e+04 Mflops = 483.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000446537; expected ratio = 0.0001obtained abs = 7.98786e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.25117; expected ratio = 0.001obtained abs = 89.9839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.839920e+05 Mflops = 356.62 -Solve time = 0.00 -Solve flops = 1.729200e+04 Mflops = 493.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000569604; expected ratio = 0.0001obtained abs = 1.01903e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.135528; expected ratio = 0.001obtained abs = 48.4795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.816100e+05 Mflops = 353.31 -Solve time = 0.00 -Solve flops = 1.719200e+04 Mflops = 477.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000639079; expected ratio = 0.0001obtained abs = 1.14335e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103478; expected ratio = 0.001obtained abs = 37.0373; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.860600e+05 Mflops = 359.30 -Solve time = 0.00 -Solve flops = 1.739400e+04 Mflops = 483.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000378547; expected ratio = 0.0001obtained abs = 6.7731e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138729; expected ratio = 0.001obtained abs = 49.6044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.850880e+05 Mflops = 349.85 -Solve time = 0.00 -Solve flops = 1.735200e+04 Mflops = 469.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000183799; expected ratio = 0.0001obtained abs = 3.28878e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.126393; expected ratio = 0.001obtained abs = 45.2208; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.861000e+05 Mflops = 360.04 -Solve time = 0.00 -Solve flops = 1.739600e+04 Mflops = 483.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000121152; expected ratio = 0.0001obtained abs = 2.16787e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107185; expected ratio = 0.001obtained abs = 38.2021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.850880e+05 Mflops = 358.08 -Solve time = 0.00 -Solve flops = 1.735200e+04 Mflops = 481.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000145416; expected ratio = 0.0001obtained abs = 2.6021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0897487; expected ratio = 0.001obtained abs = 32.1257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,124) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 198 -RHS size in solver: 198 -Factor time = 0.00 -Factor flops = 1.857400e+05 Mflops = 358.51 -Solve time = 0.00 -Solve flops = 1.737600e+04 Mflops = 482.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.58307e-05; expected ratio = 0.0001obtained abs = 1.35694e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0812978; expected ratio = 0.001obtained abs = 28.939; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36715 - Final Residual ratio : 0.00257597 - Residual ratio : 0.00076503 - Slope : -0.140191 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.19491 - Final Residual ratio : 0.00231026 - Residual ratio : 0.000723106 - Slope : -0.127704 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.06181 - Final Residual ratio : 0.00298921 - Residual ratio : 0.000976287 - Slope : -0.218487 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.95188 - Final Residual ratio : 0.00244226 - Residual ratio : 0.000827357 - Slope : -0.117978 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.91377 - Final Residual ratio : 0.00260799 - Residual ratio : 0.000895055 - Slope : -0.107821 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.75208 - Final Residual ratio : 0.00269242 - Residual ratio : 0.000978324 - Slope : -0.101829 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.63596 - Final Residual ratio : 0.00251638 - Residual ratio : 0.000954633 - Slope : -0.109727 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.52648 - Final Residual ratio : 0.0025226 - Residual ratio : 0.000998465 - Slope : -0.105165 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.42311 - Final Residual ratio : 0.00235492 - Residual ratio : 0.000971862 - Slope : -0.151297 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.39605 - Final Residual ratio : 0.0022408 - Residual ratio : 0.000935204 - Slope : -0.0997421 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 13 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 124 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 123 - - Mesh vertices: 115 - Mesh triangles: 123 - Mesh edges: 199 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0351 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000483036 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.875370e+05 Mflops = 367.05 -Solve time = 0.00 -Solve flops = 1.740400e+04 Mflops = 483.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0272991; expected ratio = 0.0001obtained abs = 0.000479514; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121903; expected ratio = 0.001obtained abs = 44.5608; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.901290e+05 Mflops = 367.15 -Solve time = 0.00 -Solve flops = 1.752200e+04 Mflops = 486.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00837444; expected ratio = 0.0001obtained abs = 0.000146946; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.133285; expected ratio = 0.001obtained abs = 48.278; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.857890e+05 Mflops = 364.31 -Solve time = 0.00 -Solve flops = 1.733000e+04 Mflops = 465.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00313626; expected ratio = 0.0001obtained abs = 5.50141e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0751286; expected ratio = 0.001obtained abs = 27.4326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.880570e+05 Mflops = 368.07 -Solve time = 0.00 -Solve flops = 1.743000e+04 Mflops = 484.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000983373; expected ratio = 0.0001obtained abs = 1.72468e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0377525; expected ratio = 0.001obtained abs = 13.7821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478983 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.887430e+05 Mflops = 369.41 -Solve time = 0.00 -Solve flops = 1.746800e+04 Mflops = 498.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000618555; expected ratio = 0.0001obtained abs = 1.08468e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.049236; expected ratio = 0.001obtained abs = 18.0942; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.886430e+05 Mflops = 359.32 -Solve time = 0.00 -Solve flops = 1.746800e+04 Mflops = 485.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000548931; expected ratio = 0.0001obtained abs = 9.6245e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.118438; expected ratio = 0.001obtained abs = 43.3452; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.835770e+05 Mflops = 362.00 -Solve time = 0.00 -Solve flops = 1.723600e+04 Mflops = 478.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000459076; expected ratio = 0.0001obtained abs = 8.0481e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1291; expected ratio = 0.001obtained abs = 47.571; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.890630e+05 Mflops = 369.17 -Solve time = 0.00 -Solve flops = 1.748000e+04 Mflops = 485.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000344611; expected ratio = 0.0001obtained abs = 6.04073e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0903337; expected ratio = 0.001obtained abs = 33.1453; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.868390e+05 Mflops = 366.37 -Solve time = 0.00 -Solve flops = 1.738000e+04 Mflops = 482.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000329821; expected ratio = 0.0001obtained abs = 5.78096e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0895023; expected ratio = 0.001obtained abs = 33.0372; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.890630e+05 Mflops = 368.49 -Solve time = 0.00 -Solve flops = 1.748000e+04 Mflops = 485.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000251159; expected ratio = 0.0001obtained abs = 4.40181e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0977589; expected ratio = 0.001obtained abs = 36.0944; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.877190e+05 Mflops = 368.09 -Solve time = 0.00 -Solve flops = 1.742400e+04 Mflops = 500.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000237847; expected ratio = 0.0001obtained abs = 4.16828e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0794556; expected ratio = 0.001obtained abs = 29.405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.890630e+05 Mflops = 369.35 -Solve time = 0.00 -Solve flops = 1.748000e+04 Mflops = 485.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000168172; expected ratio = 0.0001obtained abs = 2.94705e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0596523; expected ratio = 0.001obtained abs = 22.041; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.877190e+05 Mflops = 367.92 -Solve time = 0.00 -Solve flops = 1.742400e+04 Mflops = 483.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000155214; expected ratio = 0.0001obtained abs = 2.71988e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0499263; expected ratio = 0.001obtained abs = 18.4959; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.890630e+05 Mflops = 369.86 -Solve time = 0.00 -Solve flops = 1.748000e+04 Mflops = 485.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000140993; expected ratio = 0.0001obtained abs = 2.47057e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0467719; expected ratio = 0.001obtained abs = 17.3354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.877190e+05 Mflops = 368.09 -Solve time = 0.00 -Solve flops = 1.742400e+04 Mflops = 483.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00011038; expected ratio = 0.0001obtained abs = 1.9341e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0642399; expected ratio = 0.001obtained abs = 23.797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.890630e+05 Mflops = 369.86 -Solve time = 0.00 -Solve flops = 1.748000e+04 Mflops = 485.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.17553e-05; expected ratio = 0.0001obtained abs = 1.25729e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0433177; expected ratio = 0.001obtained abs = 16.0447; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0361 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.05634 - Final Residual ratio : 0.00376078 - Residual ratio : 0.000620965 - Slope : -0.201753 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.95254 - Final Residual ratio : 0.0042865 - Residual ratio : 0.00053901 - Slope : -0.31793 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.4207 - Final Residual ratio : 0.0123607 - Residual ratio : 0.000995169 - Slope : -0.443154 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.93299 - Final Residual ratio : 0.00669552 - Residual ratio : 0.000674069 - Slope : -0.342286 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.66699 - Final Residual ratio : 0.00586448 - Residual ratio : 0.000676645 - Slope : -0.29866 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.02104 - Final Residual ratio : 0.00446287 - Residual ratio : 0.000635642 - Slope : -0.241951 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.56122 - Final Residual ratio : 0.00280656 - Residual ratio : 0.000504666 - Slope : -0.222336 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.50223 - Final Residual ratio : 0.00208043 - Residual ratio : 0.000462089 - Slope : -0.166672 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.95159 - Final Residual ratio : 0.00315725 - Residual ratio : 0.000798982 - Slope : -0.141015 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.72424 - Final Residual ratio : 0.00369106 - Residual ratio : 0.00099109 - Slope : -0.132877 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 16 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 123 - - Mesh vertices: 115 - Mesh triangles: 123 - Mesh edges: 199 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0451 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000479937 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.844350e+05 Mflops = 366.62 -Solve time = 0.00 -Solve flops = 1.733400e+04 Mflops = 481.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0372263; expected ratio = 0.0001obtained abs = 0.000634938; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104636; expected ratio = 0.001obtained abs = 39.6203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.807850e+05 Mflops = 362.29 -Solve time = 0.00 -Solve flops = 1.715200e+04 Mflops = 476.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00536039; expected ratio = 0.0001obtained abs = 9.17173e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159237; expected ratio = 0.001obtained abs = 58.8487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.813170e+05 Mflops = 365.62 -Solve time = 0.00 -Solve flops = 1.717000e+04 Mflops = 476.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00104707; expected ratio = 0.0001obtained abs = 1.79129e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0887191; expected ratio = 0.001obtained abs = 33.0258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.813170e+05 Mflops = 364.75 -Solve time = 0.00 -Solve flops = 1.717000e+04 Mflops = 476.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000673146; expected ratio = 0.0001obtained abs = 1.15177e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0654267; expected ratio = 0.001obtained abs = 24.1953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.816790e+05 Mflops = 354.76 -Solve time = 0.00 -Solve flops = 1.719000e+04 Mflops = 493.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000359015; expected ratio = 0.0001obtained abs = 6.1432e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130678; expected ratio = 0.001obtained abs = 48.808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.808810e+05 Mflops = 362.48 -Solve time = 0.00 -Solve flops = 1.715800e+04 Mflops = 489.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000329373; expected ratio = 0.0001obtained abs = 5.63633e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.230515; expected ratio = 0.001obtained abs = 85.8381; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.808810e+05 Mflops = 363.35 -Solve time = 0.00 -Solve flops = 1.715800e+04 Mflops = 489.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000171781; expected ratio = 0.0001obtained abs = 2.93956e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.177749; expected ratio = 0.001obtained abs = 65.8432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.808810e+05 Mflops = 363.35 -Solve time = 0.00 -Solve flops = 1.715800e+04 Mflops = 489.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000229422; expected ratio = 0.0001obtained abs = 3.92588e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.151915; expected ratio = 0.001obtained abs = 57.3422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.808810e+05 Mflops = 356.85 -Solve time = 0.00 -Solve flops = 1.715800e+04 Mflops = 489.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162394; expected ratio = 0.0001obtained abs = 2.77879e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.301334; expected ratio = 0.001obtained abs = 111.799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.808810e+05 Mflops = 364.05 -Solve time = 0.00 -Solve flops = 1.715800e+04 Mflops = 476.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000156969; expected ratio = 0.0001obtained abs = 2.68598e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.199413; expected ratio = 0.001obtained abs = 74.0391; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.808810e+05 Mflops = 362.48 -Solve time = 0.00 -Solve flops = 1.715800e+04 Mflops = 489.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.88109e-05; expected ratio = 0.0001obtained abs = 1.69078e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0808349; expected ratio = 0.001obtained abs = 29.8975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.49061 - Final Residual ratio : 0.00323707 - Residual ratio : 0.000927366 - Slope : -0.124549 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.26754 - Final Residual ratio : 0.00198554 - Residual ratio : 0.000607656 - Slope : -0.116627 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12672 - Final Residual ratio : 0.00195371 - Residual ratio : 0.000624844 - Slope : -0.107751 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.08423 - Final Residual ratio : 0.00261664 - Residual ratio : 0.000848392 - Slope : -0.106262 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.09991 - Final Residual ratio : 0.00255649 - Residual ratio : 0.000824699 - Slope : -0.106805 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.90581 - Final Residual ratio : 0.00223905 - Residual ratio : 0.000770541 - Slope : -0.100123 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0521 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.71367 - Final Residual ratio : 0.0026212 - Residual ratio : 0.000965924 - Slope : -0.0968232 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.57854 - Final Residual ratio : 0.00188785 - Residual ratio : 0.000732137 - Slope : -0.0920234 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.5013 - Final Residual ratio : 0.0180998 - Residual ratio : 0.000978297 - Slope : -0.770133 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.3726 - Final Residual ratio : 0.011322 - Residual ratio : 0.000846661 - Slope : -0.494862 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 11 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 123 - - Mesh vertices: 115 - Mesh triangles: 123 - Mesh edges: 199 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0551 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000481129 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.807670e+05 Mflops = 362.25 -Solve time = 0.00 -Solve flops = 1.713800e+04 Mflops = 488.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0395578; expected ratio = 0.0001obtained abs = 0.000659453; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.132051; expected ratio = 0.001obtained abs = 47.4289; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.840670e+05 Mflops = 368.86 -Solve time = 0.00 -Solve flops = 1.731400e+04 Mflops = 480.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.011359; expected ratio = 0.0001obtained abs = 0.000190156; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.126009; expected ratio = 0.001obtained abs = 44.0424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.841870e+05 Mflops = 369.81 -Solve time = 0.00 -Solve flops = 1.732000e+04 Mflops = 481.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00222044; expected ratio = 0.0001obtained abs = 3.71626e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.055726; expected ratio = 0.001obtained abs = 19.6239; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.840670e+05 Mflops = 369.57 -Solve time = 0.00 -Solve flops = 1.731400e+04 Mflops = 494.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000526181; expected ratio = 0.0001obtained abs = 8.80687e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0480568; expected ratio = 0.001obtained abs = 16.8558; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.840670e+05 Mflops = 369.57 -Solve time = 0.00 -Solve flops = 1.731400e+04 Mflops = 480.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000440973; expected ratio = 0.0001obtained abs = 7.38088e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0734947; expected ratio = 0.001obtained abs = 25.8449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833890e+05 Mflops = 368.21 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 480.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000281834; expected ratio = 0.0001obtained abs = 4.71719e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0668079; expected ratio = 0.001obtained abs = 23.4015; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833890e+05 Mflops = 362.31 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 480.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000250972; expected ratio = 0.0001obtained abs = 4.20064e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.075206; expected ratio = 0.001obtained abs = 26.5375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833890e+05 Mflops = 368.21 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 493.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000184105; expected ratio = 0.0001obtained abs = 3.08137e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129917; expected ratio = 0.001obtained abs = 45.5799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833890e+05 Mflops = 367.51 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 493.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00021622; expected ratio = 0.0001obtained abs = 3.61887e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.156341; expected ratio = 0.001obtained abs = 55.3982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833890e+05 Mflops = 368.39 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 493.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00015198; expected ratio = 0.0001obtained abs = 2.5436e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.157205; expected ratio = 0.001obtained abs = 55.5819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833890e+05 Mflops = 368.21 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 493.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000136458; expected ratio = 0.0001obtained abs = 2.28378e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145092; expected ratio = 0.001obtained abs = 51.0996; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833890e+05 Mflops = 360.95 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 493.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000136626; expected ratio = 0.0001obtained abs = 2.28653e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0737854; expected ratio = 0.001obtained abs = 26.0177; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833890e+05 Mflops = 367.51 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 493.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00010451; expected ratio = 0.0001obtained abs = 1.74901e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0502939; expected ratio = 0.001obtained abs = 17.7304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833890e+05 Mflops = 362.48 -Solve time = 0.00 -Solve flops = 1.728200e+04 Mflops = 480.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.18788e-05; expected ratio = 0.0001obtained abs = 1.2029e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0344817; expected ratio = 0.001obtained abs = 12.1567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.09968 - Final Residual ratio : 0.00716307 - Residual ratio : 0.000787178 - Slope : -0.349712 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.98683 - Final Residual ratio : 0.00240448 - Residual ratio : 0.000805029 - Slope : -0.110534 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.46822 - Final Residual ratio : 0.00203633 - Residual ratio : 0.000825019 - Slope : -0.123309 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.63235 - Final Residual ratio : 0.00221311 - Residual ratio : 0.000840736 - Slope : -0.0906945 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.71249 - Final Residual ratio : 0.0022415 - Residual ratio : 0.000826364 - Slope : -0.0934569 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.56744 - Final Residual ratio : 0.00178063 - Residual ratio : 0.000693541 - Slope : -0.0884711 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.35126 - Final Residual ratio : 0.00152983 - Residual ratio : 0.000650645 - Slope : -0.0810251 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.1372 - Final Residual ratio : 0.001898 - Residual ratio : 0.000888078 - Slope : -0.0711767 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.01768 - Final Residual ratio : 0.00158804 - Residual ratio : 0.000787064 - Slope : -0.0695204 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.01333 - Final Residual ratio : 0.00170924 - Residual ratio : 0.000848959 - Slope : -0.0693663 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 14 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 123 - - Mesh vertices: 115 - Mesh triangles: 123 - Mesh edges: 199 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0651 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00048089 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.823750e+05 Mflops = 366.88 -Solve time = 0.00 -Solve flops = 1.726800e+04 Mflops = 479.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0316718; expected ratio = 0.0001obtained abs = 0.000518109; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113376; expected ratio = 0.001obtained abs = 42.155; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829290e+05 Mflops = 369.59 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 480.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00929835; expected ratio = 0.0001obtained abs = 0.000151893; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155773; expected ratio = 0.001obtained abs = 57.2788; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000480175 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 370.40 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00384193; expected ratio = 0.0001obtained abs = 6.27134e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0857475; expected ratio = 0.001obtained abs = 31.8542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478983 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 363.04 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000755146; expected ratio = 0.0001obtained abs = 1.23244e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0604029; expected ratio = 0.001obtained abs = 22.3783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 371.11 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0004368; expected ratio = 0.0001obtained abs = 7.1281e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101163; expected ratio = 0.001obtained abs = 37.9326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 369.68 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000393895; expected ratio = 0.0001obtained abs = 6.4271e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.160094; expected ratio = 0.001obtained abs = 60.236; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 371.11 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000288335; expected ratio = 0.0001obtained abs = 4.70424e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249911; expected ratio = 0.001obtained abs = 93.3754; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 370.40 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000242597; expected ratio = 0.0001obtained abs = 3.95769e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.160574; expected ratio = 0.001obtained abs = 59.9418; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 365.28 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 493.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000200375; expected ratio = 0.0001obtained abs = 3.26869e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0759213; expected ratio = 0.001obtained abs = 28.3715; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 370.40 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000160003; expected ratio = 0.0001obtained abs = 2.60997e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.053981; expected ratio = 0.001obtained abs = 20.1858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 360.31 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000184027; expected ratio = 0.0001obtained abs = 3.00169e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.046595; expected ratio = 0.001obtained abs = 17.4561; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 369.50 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00012798; expected ratio = 0.0001obtained abs = 2.08741e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0463494; expected ratio = 0.001obtained abs = 17.3413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.829770e+05 Mflops = 371.29 -Solve time = 0.00 -Solve flops = 1.730200e+04 Mflops = 480.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.67868e-05; expected ratio = 0.0001obtained abs = 1.5786e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0298116; expected ratio = 0.001obtained abs = 11.1673; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.82697 - Final Residual ratio : 0.00637327 - Residual ratio : 0.000933544 - Slope : -0.235193 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.68392 - Final Residual ratio : 0.0049528 - Residual ratio : 0.000570341 - Slope : -0.279967 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0681 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.62003 - Final Residual ratio : 0.00565404 - Residual ratio : 0.000587736 - Slope : -0.310141 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.00438 - Final Residual ratio : 0.00763441 - Residual ratio : 0.000847856 - Slope : -0.310232 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.67467 - Final Residual ratio : 0.00666964 - Residual ratio : 0.000869046 - Slope : -0.264414 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.31102 - Final Residual ratio : 0.00376576 - Residual ratio : 0.000596695 - Slope : -0.217492 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.34533 - Final Residual ratio : 0.00371497 - Residual ratio : 0.000694993 - Slope : -0.178054 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.77842 - Final Residual ratio : 0.00415938 - Residual ratio : 0.000870452 - Slope : -0.16463 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.57134 - Final Residual ratio : 0.00480533 - Residual ratio : 0.000634675 - Slope : -0.270233 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.8046 - Final Residual ratio : 0.0164174 - Residual ratio : 0.000752931 - Slope : -0.80697 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 13 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 123 - - Mesh vertices: 115 - Mesh triangles: 123 - Mesh edges: 199 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0751 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000479937 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.776840e+05 Mflops = 355.39 -Solve time = 0.00 -Solve flops = 1.704000e+04 Mflops = 473.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0421862; expected ratio = 0.0001obtained abs = 0.000665916; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106524; expected ratio = 0.001obtained abs = 39.4175; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.791880e+05 Mflops = 359.77 -Solve time = 0.00 -Solve flops = 1.711400e+04 Mflops = 488.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0138122; expected ratio = 0.0001obtained abs = 0.000219558; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.154916; expected ratio = 0.001obtained abs = 55.2526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.776100e+05 Mflops = 357.98 -Solve time = 0.00 -Solve flops = 1.703200e+04 Mflops = 473.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00243042; expected ratio = 0.0001obtained abs = 3.86072e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0835812; expected ratio = 0.001obtained abs = 30.1697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.776100e+05 Mflops = 358.15 -Solve time = 0.00 -Solve flops = 1.703200e+04 Mflops = 473.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000646688; expected ratio = 0.0001obtained abs = 1.02738e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127721; expected ratio = 0.001obtained abs = 45.5859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.784900e+05 Mflops = 358.37 -Solve time = 0.00 -Solve flops = 1.707600e+04 Mflops = 474.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000457562; expected ratio = 0.0001obtained abs = 7.26966e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120766; expected ratio = 0.001obtained abs = 43.4936; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000479937 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.776100e+05 Mflops = 349.09 -Solve time = 0.00 -Solve flops = 1.703200e+04 Mflops = 473.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000390243; expected ratio = 0.0001obtained abs = 6.20034e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.147329; expected ratio = 0.001obtained abs = 52.5087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.776100e+05 Mflops = 357.46 -Solve time = 0.00 -Solve flops = 1.703200e+04 Mflops = 485.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000192155; expected ratio = 0.0001obtained abs = 3.05307e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.148281; expected ratio = 0.001obtained abs = 53.3042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.776100e+05 Mflops = 357.29 -Solve time = 0.00 -Solve flops = 1.703200e+04 Mflops = 489.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000119819; expected ratio = 0.0001obtained abs = 1.90379e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.132649; expected ratio = 0.001obtained abs = 47.6642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.776100e+05 Mflops = 358.15 -Solve time = 0.00 -Solve flops = 1.703200e+04 Mflops = 485.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.41275e-05; expected ratio = 0.0001obtained abs = 1.49556e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101259; expected ratio = 0.001obtained abs = 36.2591; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.07838 - Final Residual ratio : 0.00415411 - Residual ratio : 0.000817999 - Slope : -0.181222 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.31732 - Final Residual ratio : 0.00486796 - Residual ratio : 0.000915491 - Slope : -0.183188 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.16258 - Final Residual ratio : 0.0032417 - Residual ratio : 0.000627922 - Slope : -0.198436 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.80887 - Final Residual ratio : 0.00270451 - Residual ratio : 0.000562401 - Slope : -0.155037 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.46221 - Final Residual ratio : 0.00357272 - Residual ratio : 0.000800662 - Slope : -0.148621 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.04788 - Final Residual ratio : 0.00395152 - Residual ratio : 0.000976194 - Slope : -0.139446 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.6701 - Final Residual ratio : 0.0023167 - Residual ratio : 0.000631237 - Slope : -0.126475 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.37909 - Final Residual ratio : 0.00331406 - Residual ratio : 0.000980757 - Slope : -0.198575 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.2137 - Final Residual ratio : 0.00223445 - Residual ratio : 0.000695289 - Slope : -0.114695 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.07426 - Final Residual ratio : 0.00227068 - Residual ratio : 0.000738608 - Slope : -0.109714 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 9 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 123 - - Mesh vertices: 115 - Mesh triangles: 123 - Mesh edges: 199 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0851 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000481129 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.749800e+05 Mflops = 357.83 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 470.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0351623; expected ratio = 0.0001obtained abs = 0.000544834; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117384; expected ratio = 0.001obtained abs = 43.0446; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.759940e+05 Mflops = 360.61 -Solve time = 0.00 -Solve flops = 1.699800e+04 Mflops = 472.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00762437; expected ratio = 0.0001obtained abs = 0.000118082; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137743; expected ratio = 0.001obtained abs = 49.9349; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.767500e+05 Mflops = 362.16 -Solve time = 0.00 -Solve flops = 1.703800e+04 Mflops = 473.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00320955; expected ratio = 0.0001obtained abs = 4.9678e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.081842; expected ratio = 0.001obtained abs = 29.9631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000477076 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.769660e+05 Mflops = 363.49 -Solve time = 0.00 -Solve flops = 1.704400e+04 Mflops = 473.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000648078; expected ratio = 0.0001obtained abs = 1.00301e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.062517; expected ratio = 0.001obtained abs = 22.7626; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.768460e+05 Mflops = 353.04 -Solve time = 0.00 -Solve flops = 1.703800e+04 Mflops = 473.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000347661; expected ratio = 0.0001obtained abs = 5.38023e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119644; expected ratio = 0.001obtained abs = 44.4946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.768460e+05 Mflops = 362.36 -Solve time = 0.00 -Solve flops = 1.703800e+04 Mflops = 486.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000321326; expected ratio = 0.0001obtained abs = 4.97222e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.205496; expected ratio = 0.001obtained abs = 74.782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.761680e+05 Mflops = 361.14 -Solve time = 0.00 -Solve flops = 1.700600e+04 Mflops = 485.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000258457; expected ratio = 0.0001obtained abs = 3.99906e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127627; expected ratio = 0.001obtained abs = 46.7898; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.761680e+05 Mflops = 360.97 -Solve time = 0.00 -Solve flops = 1.700600e+04 Mflops = 472.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000219537; expected ratio = 0.0001obtained abs = 3.39661e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0878245; expected ratio = 0.001obtained abs = 32.1767; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.761680e+05 Mflops = 361.14 -Solve time = 0.00 -Solve flops = 1.700600e+04 Mflops = 472.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000194098; expected ratio = 0.0001obtained abs = 3.00286e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0565056; expected ratio = 0.001obtained abs = 20.7715; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.761680e+05 Mflops = 361.68 -Solve time = 0.00 -Solve flops = 1.700600e+04 Mflops = 488.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000152692; expected ratio = 0.0001obtained abs = 2.36214e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0266865; expected ratio = 0.001obtained abs = 9.80527; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.761680e+05 Mflops = 360.97 -Solve time = 0.00 -Solve flops = 1.700600e+04 Mflops = 485.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00013531; expected ratio = 0.0001obtained abs = 2.09318e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0145953; expected ratio = 0.001obtained abs = 5.36765; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.761680e+05 Mflops = 361.14 -Solve time = 0.00 -Solve flops = 1.700600e+04 Mflops = 472.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000165123; expected ratio = 0.0001obtained abs = 2.55425e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119318; expected ratio = 0.001obtained abs = 4.39239; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.761680e+05 Mflops = 360.97 -Solve time = 0.00 -Solve flops = 1.700600e+04 Mflops = 472.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000114597; expected ratio = 0.0001obtained abs = 1.77261e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0239478; expected ratio = 0.001obtained abs = 8.81073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.761680e+05 Mflops = 360.97 -Solve time = 0.00 -Solve flops = 1.700600e+04 Mflops = 488.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.16021e-05; expected ratio = 0.0001obtained abs = 1.26221e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136122; expected ratio = 0.001obtained abs = 5.01073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.4261 - Final Residual ratio : 0.0368942 - Residual ratio : 0.000677877 - Slope : -1.81297 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 59.1887 - Final Residual ratio : 0.0434441 - Residual ratio : 0.000733993 - Slope : -1.97151 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.2055 - Final Residual ratio : 0.0100072 - Residual ratio : 0.000980569 - Slope : -0.377612 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.9578 - Final Residual ratio : 0.00896821 - Residual ratio : 0.000818435 - Slope : -0.36496 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9132 - Final Residual ratio : 0.00901497 - Residual ratio : 0.000756721 - Slope : -0.396806 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0911 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.86 - Final Residual ratio : 0.00787334 - Residual ratio : 0.000724982 - Slope : -0.361739 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 206.615 - Final Residual ratio : 0.168276 - Residual ratio : 0.000814442 - Slope : -8.60194 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 99.936 - Final Residual ratio : 0.0964701 - Residual ratio : 0.000965319 - Slope : -4.15998 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.3634 - Final Residual ratio : 0.0264306 - Residual ratio : 0.000792204 - Slope : -1.28219 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.6329 - Final Residual ratio : 0.0175841 - Residual ratio : 0.000997235 - Slope : -1.03619 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.0951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 14 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 121 - - Mesh vertices: 114 - Mesh triangles: 121 - Mesh edges: 196 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.0951 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.759860e+05 Mflops = 354.70 -Solve time = 0.00 -Solve flops = 1.683000e+04 Mflops = 497.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0412015; expected ratio = 0.0001obtained abs = 0.000612482; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104557; expected ratio = 0.001obtained abs = 38.6995; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.762400e+05 Mflops = 356.76 -Solve time = 0.00 -Solve flops = 1.680000e+04 Mflops = 492.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0119008; expected ratio = 0.0001obtained abs = 0.000178009; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.156595; expected ratio = 0.001obtained abs = 56.2056; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.776640e+05 Mflops = 359.64 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 494.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00188831; expected ratio = 0.0001obtained abs = 2.82235e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109969; expected ratio = 0.001obtained abs = 40.0922; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.775140e+05 Mflops = 359.34 -Solve time = 0.00 -Solve flops = 1.684000e+04 Mflops = 497.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000601216; expected ratio = 0.0001obtained abs = 8.98687e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.200971; expected ratio = 0.001obtained abs = 72.5494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.775140e+05 Mflops = 359.34 -Solve time = 0.00 -Solve flops = 1.684000e+04 Mflops = 480.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000678923; expected ratio = 0.0001obtained abs = 1.01489e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164638; expected ratio = 0.001obtained abs = 59.5947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.777540e+05 Mflops = 359.82 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000818117; expected ratio = 0.0001obtained abs = 1.22288e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.202056; expected ratio = 0.001obtained abs = 72.8579; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.777000e+05 Mflops = 351.24 -Solve time = 0.00 -Solve flops = 1.690000e+04 Mflops = 495.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00137986; expected ratio = 0.0001obtained abs = 2.06273e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.200026; expected ratio = 0.001obtained abs = 72.5062; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.762760e+05 Mflops = 358.39 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 493.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00157607; expected ratio = 0.0001obtained abs = 2.35582e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0673258; expected ratio = 0.001obtained abs = 24.3694; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.762760e+05 Mflops = 359.08 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 493.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000636342; expected ratio = 0.0001obtained abs = 9.51232e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0563799; expected ratio = 0.001obtained abs = 20.4096; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.769000e+05 Mflops = 359.48 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 497.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000211114; expected ratio = 0.0001obtained abs = 3.15586e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0559439; expected ratio = 0.001obtained abs = 20.2894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.769000e+05 Mflops = 359.48 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 494.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.96363e-05; expected ratio = 0.0001obtained abs = 1.3399e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0747091; expected ratio = 0.001obtained abs = 26.9313; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.0961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.2824 - Final Residual ratio : 0.0183287 - Residual ratio : 0.000861217 - Slope : -1.4176 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.2758 - Final Residual ratio : 0.0170699 - Residual ratio : 0.000841887 - Slope : -0.880815 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.5869 - Final Residual ratio : 0.0171827 - Residual ratio : 0.000877256 - Slope : -0.889532 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.0991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.3871 - Final Residual ratio : 0.0116059 - Residual ratio : 0.0006675 - Slope : -1.33658 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.0991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.117 - Final Residual ratio : 0.0132299 - Residual ratio : 0.00087517 - Slope : -0.719225 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.1729 - Final Residual ratio : 0.0125378 - Residual ratio : 0.000951786 - Slope : -0.57219 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5929 - Final Residual ratio : 0.00989144 - Residual ratio : 0.000853233 - Slope : -0.503609 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3295 - Final Residual ratio : 0.00573992 - Residual ratio : 0.000555681 - Slope : -0.44886 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.31866 - Final Residual ratio : 0.00789672 - Residual ratio : 0.00084741 - Slope : -0.404816 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.52497 - Final Residual ratio : 0.00845693 - Residual ratio : 0.000992019 - Slope : -0.34066 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 11 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 121 - - Mesh vertices: 114 - Mesh triangles: 121 - Mesh edges: 196 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1051 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.770770e+05 Mflops = 361.42 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 481.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0372061; expected ratio = 0.0001obtained abs = 0.00054198; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.118489; expected ratio = 0.001obtained abs = 43.1238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.768970e+05 Mflops = 361.76 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 497.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00422366; expected ratio = 0.0001obtained abs = 6.15927e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.13292; expected ratio = 0.001obtained abs = 47.564; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.785470e+05 Mflops = 363.53 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 499.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00153874; expected ratio = 0.0001obtained abs = 2.24336e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0791903; expected ratio = 0.001obtained abs = 28.6345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.786130e+05 Mflops = 364.55 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 495.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000510789; expected ratio = 0.0001obtained abs = 7.44606e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145756; expected ratio = 0.001obtained abs = 52.3599; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.785470e+05 Mflops = 362.83 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 495.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000468519; expected ratio = 0.0001obtained abs = 6.82946e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.133219; expected ratio = 0.001obtained abs = 48.1858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.785470e+05 Mflops = 355.09 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 482.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000538006; expected ratio = 0.0001obtained abs = 7.84148e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100758; expected ratio = 0.001obtained abs = 36.7508; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.770690e+05 Mflops = 362.11 -Solve time = 0.00 -Solve flops = 1.686600e+04 Mflops = 481.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000354883; expected ratio = 0.0001obtained abs = 5.17217e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.234369; expected ratio = 0.001obtained abs = 84.4619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.756430e+05 Mflops = 361.30 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 483.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00022832; expected ratio = 0.0001obtained abs = 3.32743e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.178288; expected ratio = 0.001obtained abs = 64.7359; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.770690e+05 Mflops = 363.70 -Solve time = 0.00 -Solve flops = 1.686600e+04 Mflops = 481.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000151703; expected ratio = 0.0001obtained abs = 2.21074e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0908795; expected ratio = 0.001obtained abs = 32.807; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.758670e+05 Mflops = 361.06 -Solve time = 0.00 -Solve flops = 1.685200e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000145599; expected ratio = 0.0001obtained abs = 2.1217e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0709288; expected ratio = 0.001obtained abs = 25.7359; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.770690e+05 Mflops = 363.52 -Solve time = 0.00 -Solve flops = 1.686600e+04 Mflops = 484.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000106791; expected ratio = 0.0001obtained abs = 1.55613e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.04427; expected ratio = 0.001obtained abs = 16.0189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.764530e+05 Mflops = 362.26 -Solve time = 0.00 -Solve flops = 1.686600e+04 Mflops = 481.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.8498e-05; expected ratio = 0.0001obtained abs = 1.43525e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0346207; expected ratio = 0.001obtained abs = 12.557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1061 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.87691 - Final Residual ratio : 0.00720473 - Residual ratio : 0.000914665 - Slope : -0.562122 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.35452 - Final Residual ratio : 0.00650931 - Residual ratio : 0.000885076 - Slope : -0.319479 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.89356 - Final Residual ratio : 0.00651316 - Residual ratio : 0.000944817 - Slope : -0.28696 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.46134 - Final Residual ratio : 0.00533988 - Residual ratio : 0.000826435 - Slope : -0.269 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.06058 - Final Residual ratio : 0.00535046 - Residual ratio : 0.000882831 - Slope : -0.263271 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.64437 - Final Residual ratio : 0.00505166 - Residual ratio : 0.00089499 - Slope : -0.225573 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.27336 - Final Residual ratio : 0.00353386 - Residual ratio : 0.000670133 - Slope : -0.195179 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.9406 - Final Residual ratio : 0.00285908 - Residual ratio : 0.00057869 - Slope : -0.182879 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.64456 - Final Residual ratio : 0.00443077 - Residual ratio : 0.00095397 - Slope : -0.178467 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.40315 - Final Residual ratio : 0.00387573 - Residual ratio : 0.000880217 - Slope : -0.175971 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 12 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 121 - - Mesh vertices: 114 - Mesh triangles: 121 - Mesh edges: 196 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1151 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.744040e+05 Mflops = 358.05 -Solve time = 0.00 -Solve flops = 1.670800e+04 Mflops = 490.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0397589; expected ratio = 0.0001obtained abs = 0.00056231; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0986954; expected ratio = 0.001obtained abs = 36.2824; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.746740e+05 Mflops = 360.19 -Solve time = 0.00 -Solve flops = 1.670400e+04 Mflops = 489.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00666093; expected ratio = 0.0001obtained abs = 9.45519e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.160572; expected ratio = 0.001obtained abs = 57.4616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.756340e+05 Mflops = 361.29 -Solve time = 0.00 -Solve flops = 1.674000e+04 Mflops = 494.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00100223; expected ratio = 0.0001obtained abs = 1.42204e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0936805; expected ratio = 0.001obtained abs = 33.9652; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.760840e+05 Mflops = 361.50 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 494.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000439312; expected ratio = 0.0001obtained abs = 6.23273e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170958; expected ratio = 0.001obtained abs = 61.6363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.763240e+05 Mflops = 361.46 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 491.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000532023; expected ratio = 0.0001obtained abs = 7.54799e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.157242; expected ratio = 0.001obtained abs = 56.8524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.746060e+05 Mflops = 360.05 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 493.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000572067; expected ratio = 0.0001obtained abs = 8.11545e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.187147; expected ratio = 0.001obtained abs = 67.5207; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.754460e+05 Mflops = 361.08 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 491.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000655049; expected ratio = 0.0001obtained abs = 9.2928e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.221279; expected ratio = 0.001obtained abs = 80.6794; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.748460e+05 Mflops = 360.37 -Solve time = 0.00 -Solve flops = 1.673400e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000653287; expected ratio = 0.0001obtained abs = 9.26708e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.357973; expected ratio = 0.001obtained abs = 131.712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.756860e+05 Mflops = 362.28 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 491.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000336524; expected ratio = 0.0001obtained abs = 4.77379e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.363624; expected ratio = 0.001obtained abs = 132.404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.748460e+05 Mflops = 360.37 -Solve time = 0.00 -Solve flops = 1.673400e+04 Mflops = 494.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000156071; expected ratio = 0.0001obtained abs = 2.21387e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185645; expected ratio = 0.001obtained abs = 66.8978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.756860e+05 Mflops = 354.10 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 495.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000246524; expected ratio = 0.0001obtained abs = 3.49691e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155795; expected ratio = 0.001obtained abs = 56.5348; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.748460e+05 Mflops = 361.26 -Solve time = 0.00 -Solve flops = 1.673400e+04 Mflops = 427.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000140051; expected ratio = 0.0001obtained abs = 1.98651e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137717; expected ratio = 0.001obtained abs = 49.5675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.756860e+05 Mflops = 361.57 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 491.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000128464; expected ratio = 0.0001obtained abs = 1.82216e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.132975; expected ratio = 0.001obtained abs = 48.22; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.748460e+05 Mflops = 361.97 -Solve time = 0.00 -Solve flops = 1.673400e+04 Mflops = 490.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.94371e-05; expected ratio = 0.0001obtained abs = 1.26857e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101597; expected ratio = 0.001obtained abs = 36.5986; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.5614 - Final Residual ratio : 0.00922225 - Residual ratio : 0.000873202 - Slope : -0.363869 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.0619 - Final Residual ratio : 0.0112834 - Residual ratio : 0.000863844 - Slope : -0.501947 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.4829 - Final Residual ratio : 0.0131034 - Residual ratio : 0.000904747 - Slope : -0.466768 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.6193 - Final Residual ratio : 0.0105765 - Residual ratio : 0.00077658 - Slope : -0.469266 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5478 - Final Residual ratio : 0.00872654 - Residual ratio : 0.00075569 - Slope : -0.397898 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.42637 - Final Residual ratio : 0.00866272 - Residual ratio : 0.000918988 - Slope : -0.313923 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.1221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.08917 - Final Residual ratio : 0.00736968 - Residual ratio : 0.000911055 - Slope : -0.4754 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.56139 - Final Residual ratio : 0.00624208 - Residual ratio : 0.00082552 - Slope : -0.290582 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.28701 - Final Residual ratio : 0.00727664 - Residual ratio : 0.000998577 - Slope : -0.25999 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.87229 - Final Residual ratio : 0.00606838 - Residual ratio : 0.000883022 - Slope : -0.245222 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 14 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 121 - - Mesh vertices: 114 - Mesh triangles: 121 - Mesh edges: 196 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1251 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.737960e+05 Mflops = 344.98 -Solve time = 0.00 -Solve flops = 1.669200e+04 Mflops = 476.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0393535; expected ratio = 0.0001obtained abs = 0.000542082; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140077; expected ratio = 0.001obtained abs = 50.7769; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.765140e+05 Mflops = 362.56 -Solve time = 0.00 -Solve flops = 1.680000e+04 Mflops = 479.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00401092; expected ratio = 0.0001obtained abs = 5.53436e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10874; expected ratio = 0.001obtained abs = 38.8622; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.765140e+05 Mflops = 362.56 -Solve time = 0.00 -Solve flops = 1.680000e+04 Mflops = 479.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00133095; expected ratio = 0.0001obtained abs = 1.83596e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0545945; expected ratio = 0.001obtained abs = 19.6226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.00044179 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.776080e+05 Mflops = 363.21 -Solve time = 0.00 -Solve flops = 1.681200e+04 Mflops = 493.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000549982; expected ratio = 0.0001obtained abs = 7.58609e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0587144; expected ratio = 0.001obtained abs = 21.0421; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000681162 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.765060e+05 Mflops = 359.38 -Solve time = 0.00 -Solve flops = 1.676200e+04 Mflops = 495.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000412276; expected ratio = 0.0001obtained abs = 5.68649e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0979407; expected ratio = 0.001obtained abs = 35.4117; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.751780e+05 Mflops = 358.94 -Solve time = 0.00 -Solve flops = 1.673800e+04 Mflops = 490.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000255804; expected ratio = 0.0001obtained abs = 3.52805e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.141467; expected ratio = 0.001obtained abs = 50.5226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.742180e+05 Mflops = 357.85 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000268533; expected ratio = 0.0001obtained abs = 3.70344e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.141843; expected ratio = 0.001obtained abs = 51.4802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.750280e+05 Mflops = 359.33 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 494.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000161922; expected ratio = 0.0001obtained abs = 2.23297e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.169296; expected ratio = 0.001obtained abs = 60.8437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.736020e+05 Mflops = 356.41 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000165517; expected ratio = 0.0001obtained abs = 2.2825e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134212; expected ratio = 0.001obtained abs = 48.493; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.750280e+05 Mflops = 353.62 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 490.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.71079e-05; expected ratio = 0.0001obtained abs = 1.33907e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0829444; expected ratio = 0.001obtained abs = 29.8411; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.29025 - Final Residual ratio : 0.00288782 - Residual ratio : 0.000459094 - Slope : -0.224549 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.76638 - Final Residual ratio : 0.00490781 - Residual ratio : 0.000851109 - Slope : -0.213388 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.43432 - Final Residual ratio : 0.00474592 - Residual ratio : 0.000873323 - Slope : -0.193913 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.24019 - Final Residual ratio : 0.00297468 - Residual ratio : 0.000567667 - Slope : -0.187044 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.06667 - Final Residual ratio : 0.00272392 - Residual ratio : 0.000537615 - Slope : -0.180855 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.8507 - Final Residual ratio : 0.00340811 - Residual ratio : 0.000702603 - Slope : -0.179529 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.68558 - Final Residual ratio : 0.00449625 - Residual ratio : 0.000959592 - Slope : -0.173374 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.60959 - Final Residual ratio : 0.00350287 - Residual ratio : 0.000759908 - Slope : -0.164503 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.55898 - Final Residual ratio : 0.00305872 - Residual ratio : 0.000670922 - Slope : -0.162711 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.44285 - Final Residual ratio : 0.00261099 - Residual ratio : 0.000587684 - Slope : -0.15858 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 121 - - Mesh vertices: 114 - Mesh triangles: 121 - Mesh edges: 196 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1351 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.719640e+05 Mflops = 348.78 -Solve time = 0.00 -Solve flops = 1.662400e+04 Mflops = 474.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0430256; expected ratio = 0.0001obtained abs = 0.000574628; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11585; expected ratio = 0.001obtained abs = 42.4668; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.730260e+05 Mflops = 352.29 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 490.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00506397; expected ratio = 0.0001obtained abs = 6.78256e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137901; expected ratio = 0.001obtained abs = 49.5216; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.746760e+05 Mflops = 355.14 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 489.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116584; expected ratio = 0.0001obtained abs = 1.56088e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0893559; expected ratio = 0.001obtained abs = 32.4943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.747420e+05 Mflops = 355.96 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 489.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000464953; expected ratio = 0.0001obtained abs = 6.22413e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.184226; expected ratio = 0.001obtained abs = 66.3983; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.737980e+05 Mflops = 354.73 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 488.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000596421; expected ratio = 0.0001obtained abs = 7.98356e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16031; expected ratio = 0.001obtained abs = 58.2803; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.731980e+05 Mflops = 354.19 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000588002; expected ratio = 0.0001obtained abs = 7.87009e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.232773; expected ratio = 0.001obtained abs = 84.192; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.732580e+05 Mflops = 353.62 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00115762; expected ratio = 0.0001obtained abs = 1.54942e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243876; expected ratio = 0.001obtained abs = 88.6614; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.740380e+05 Mflops = 355.22 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 503.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000988677; expected ratio = 0.0001obtained abs = 1.32332e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.133182; expected ratio = 0.001obtained abs = 48.2904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.00044322 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.740380e+05 Mflops = 350.27 -Solve time = 0.00 -Solve flops = 1.667200e+04 Mflops = 475.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000563236; expected ratio = 0.0001obtained abs = 7.53927e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243087; expected ratio = 0.001obtained abs = 89.1926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.731980e+05 Mflops = 353.33 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 491.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000418965; expected ratio = 0.0001obtained abs = 5.60741e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.25883; expected ratio = 0.001obtained abs = 94.5277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.717720e+05 Mflops = 352.65 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 490.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000285718; expected ratio = 0.0001obtained abs = 3.82392e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164626; expected ratio = 0.001obtained abs = 60.0372; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.731980e+05 Mflops = 354.19 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 491.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000163776; expected ratio = 0.0001obtained abs = 2.19176e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.151665; expected ratio = 0.001obtained abs = 55.1212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.717720e+05 Mflops = 352.65 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 490.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000155484; expected ratio = 0.0001obtained abs = 2.08075e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0910568; expected ratio = 0.001obtained abs = 33.111; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.731980e+05 Mflops = 353.33 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 505.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000151538; expected ratio = 0.0001obtained abs = 2.02785e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0555798; expected ratio = 0.001obtained abs = 20.2125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.725820e+05 Mflops = 352.24 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 502.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000120375; expected ratio = 0.0001obtained abs = 1.61078e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0411707; expected ratio = 0.001obtained abs = 14.9842; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.731980e+05 Mflops = 353.50 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 505.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.91064e-05; expected ratio = 0.0001obtained abs = 9.24712e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0296603; expected ratio = 0.001obtained abs = 10.7871; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.22209 - Final Residual ratio : 0.00336654 - Residual ratio : 0.000797363 - Slope : -0.156249 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.97872 - Final Residual ratio : 0.0037797 - Residual ratio : 0.000949979 - Slope : -0.158998 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79474 - Final Residual ratio : 0.00304499 - Residual ratio : 0.000802425 - Slope : -0.135418 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.67868 - Final Residual ratio : 0.00247914 - Residual ratio : 0.000673922 - Slope : -0.131293 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.57439 - Final Residual ratio : 0.00311194 - Residual ratio : 0.000870619 - Slope : -0.13227 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.434 - Final Residual ratio : 0.00279201 - Residual ratio : 0.00081305 - Slope : -0.127082 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.31405 - Final Residual ratio : 0.00299793 - Residual ratio : 0.000904614 - Slope : -0.127348 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.27544 - Final Residual ratio : 0.000786906 - Residual ratio : 0.000240244 - Slope : -0.121284 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.30489 - Final Residual ratio : 0.00296992 - Residual ratio : 0.000898642 - Slope : -0.126997 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.31448 - Final Residual ratio : 0.00199206 - Residual ratio : 0.000601015 - Slope : -0.122685 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 16 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 121 - - Mesh vertices: 114 - Mesh triangles: 121 - Mesh edges: 196 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1451 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720720e+05 Mflops = 351.20 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 487.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0452449; expected ratio = 0.0001obtained abs = 0.000585357; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10727; expected ratio = 0.001obtained abs = 39.2401; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.725940e+05 Mflops = 352.96 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 504.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00579718; expected ratio = 0.0001obtained abs = 7.52852e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159013; expected ratio = 0.001obtained abs = 56.5794; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.743940e+05 Mflops = 355.25 -Solve time = 0.00 -Solve flops = 1.666600e+04 Mflops = 488.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000980827; expected ratio = 0.0001obtained abs = 1.27334e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100042; expected ratio = 0.001obtained abs = 36.0795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.740040e+05 Mflops = 354.46 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000437874; expected ratio = 0.0001obtained abs = 5.68416e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.243838; expected ratio = 0.001obtained abs = 87.8155; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.717160e+05 Mflops = 351.16 -Solve time = 0.00 -Solve flops = 1.658800e+04 Mflops = 489.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000617907; expected ratio = 0.0001obtained abs = 8.02099e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.218069; expected ratio = 0.001obtained abs = 78.2247; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.722560e+05 Mflops = 350.90 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000597886; expected ratio = 0.0001obtained abs = 7.76037e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.331823; expected ratio = 0.001obtained abs = 121.887; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.713400e+05 Mflops = 351.08 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00030043; expected ratio = 0.0001obtained abs = 3.89955e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.36246; expected ratio = 0.001obtained abs = 130.628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721500e+05 Mflops = 352.05 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 491.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000172553; expected ratio = 0.0001obtained abs = 2.23964e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.208773; expected ratio = 0.001obtained abs = 74.9528; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.719560e+05 Mflops = 351.65 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 473.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000258956; expected ratio = 0.0001obtained abs = 3.361e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.175019; expected ratio = 0.001obtained abs = 62.9211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721500e+05 Mflops = 352.05 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000166663; expected ratio = 0.0001obtained abs = 2.16303e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.157484; expected ratio = 0.001obtained abs = 56.3802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.736060e+05 Mflops = 354.33 -Solve time = 0.00 -Solve flops = 1.666000e+04 Mflops = 488.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162143; expected ratio = 0.0001obtained abs = 2.10435e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.157077; expected ratio = 0.001obtained abs = 56.5058; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436783 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721500e+05 Mflops = 352.05 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000133904; expected ratio = 0.0001obtained abs = 1.73784e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145709; expected ratio = 0.001obtained abs = 52.1308; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.719560e+05 Mflops = 351.65 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000132326; expected ratio = 0.0001obtained abs = 1.71735e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144822; expected ratio = 0.001obtained abs = 52.0934; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721500e+05 Mflops = 351.36 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000119313; expected ratio = 0.0001obtained abs = 1.54848e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11405; expected ratio = 0.001obtained abs = 40.7823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.719560e+05 Mflops = 351.65 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000104189; expected ratio = 0.0001obtained abs = 1.35218e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110717; expected ratio = 0.001obtained abs = 39.8135; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721500e+05 Mflops = 351.36 -Solve time = 0.00 -Solve flops = 1.663000e+04 Mflops = 487.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000101475; expected ratio = 0.0001obtained abs = 1.31698e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0644884; expected ratio = 0.001obtained abs = 23.0978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000438213 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.713400e+05 Mflops = 351.08 -Solve time = 0.00 -Solve flops = 1.660000e+04 Mflops = 504.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.83861e-05; expected ratio = 0.0001obtained abs = 6.27965e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0647046; expected ratio = 0.001obtained abs = 23.2753; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.738 - Final Residual ratio : 0.00282822 - Residual ratio : 0.000756613 - Slope : -0.133399 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.51584 - Final Residual ratio : 0.00338777 - Residual ratio : 0.000963572 - Slope : -0.135094 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.53211 - Final Residual ratio : 0.00255402 - Residual ratio : 0.000723086 - Slope : -0.126055 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36342 - Final Residual ratio : 0.00238689 - Residual ratio : 0.000709663 - Slope : -0.115898 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11111 - Final Residual ratio : 0.00281153 - Residual ratio : 0.000903707 - Slope : -0.111011 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.86243 - Final Residual ratio : 0.00238733 - Residual ratio : 0.00083402 - Slope : -0.105928 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.67132 - Final Residual ratio : 0.00230602 - Residual ratio : 0.000863249 - Slope : -0.102654 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.5681 - Final Residual ratio : 0.00226521 - Residual ratio : 0.000882057 - Slope : -0.10691 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.53665 - Final Residual ratio : 0.00209633 - Residual ratio : 0.000826416 - Slope : -0.105607 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.52198 - Final Residual ratio : 0.00203344 - Residual ratio : 0.000806288 - Slope : -0.096921 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 17 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 121 - - Mesh vertices: 114 - Mesh triangles: 121 - Mesh edges: 196 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1551 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.791200e+05 Mflops = 361.89 -Solve time = 0.00 -Solve flops = 1.691800e+04 Mflops = 496.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0442147; expected ratio = 0.0001obtained abs = 0.000555442; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106354; expected ratio = 0.001obtained abs = 38.8078; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.794580e+05 Mflops = 363.98 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 498.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00444759; expected ratio = 0.0001obtained abs = 5.59639e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.15852; expected ratio = 0.001obtained abs = 56.8988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.809500e+05 Mflops = 366.29 -Solve time = 0.00 -Solve flops = 1.694200e+04 Mflops = 496.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00174185; expected ratio = 0.0001obtained abs = 2.18987e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0994237; expected ratio = 0.001obtained abs = 36.277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.805600e+05 Mflops = 365.50 -Solve time = 0.00 -Solve flops = 1.692400e+04 Mflops = 496.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000768122; expected ratio = 0.0001obtained abs = 9.6533e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.253626; expected ratio = 0.001obtained abs = 92.9113; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.801620e+05 Mflops = 366.29 -Solve time = 0.00 -Solve flops = 1.693600e+04 Mflops = 496.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000620946; expected ratio = 0.0001obtained abs = 7.80189e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.225839; expected ratio = 0.001obtained abs = 82.5412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.793220e+05 Mflops = 363.70 -Solve time = 0.00 -Solve flops = 1.690600e+04 Mflops = 499.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000463965; expected ratio = 0.0001obtained abs = 5.82847e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.186295; expected ratio = 0.001obtained abs = 68.1136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.782720e+05 Mflops = 363.86 -Solve time = 0.00 -Solve flops = 1.686400e+04 Mflops = 481.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000416171; expected ratio = 0.0001obtained abs = 5.22762e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.2468; expected ratio = 0.001obtained abs = 90.942; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.784660e+05 Mflops = 362.67 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 499.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000344612; expected ratio = 0.0001obtained abs = 4.32811e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.268036; expected ratio = 0.001obtained abs = 98.5671; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.799220e+05 Mflops = 365.62 -Solve time = 0.00 -Solve flops = 1.692400e+04 Mflops = 482.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000404351; expected ratio = 0.0001obtained abs = 5.07843e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.274999; expected ratio = 0.001obtained abs = 101.47; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.806180e+05 Mflops = 366.51 -Solve time = 0.00 -Solve flops = 1.694800e+04 Mflops = 483.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000377991; expected ratio = 0.0001obtained abs = 4.74683e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.293811; expected ratio = 0.001obtained abs = 108.425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.799220e+05 Mflops = 365.62 -Solve time = 0.00 -Solve flops = 1.692400e+04 Mflops = 496.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000557641; expected ratio = 0.0001obtained abs = 7.00313e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.322074; expected ratio = 0.001obtained abs = 119.448; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.806180e+05 Mflops = 366.33 -Solve time = 0.00 -Solve flops = 1.694800e+04 Mflops = 497.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000498894; expected ratio = 0.0001obtained abs = 6.26451e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.407719; expected ratio = 0.001obtained abs = 153.27; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.799220e+05 Mflops = 366.33 -Solve time = 0.00 -Solve flops = 1.692400e+04 Mflops = 499.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000587629; expected ratio = 0.0001obtained abs = 7.3792e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.46208; expected ratio = 0.001obtained abs = 174.085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.804740e+05 Mflops = 358.07 -Solve time = 0.00 -Solve flops = 1.694200e+04 Mflops = 483.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000395971; expected ratio = 0.0001obtained abs = 4.97181e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.475413; expected ratio = 0.001obtained abs = 179.042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.799220e+05 Mflops = 366.33 -Solve time = 0.00 -Solve flops = 1.692400e+04 Mflops = 482.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000401556; expected ratio = 0.0001obtained abs = 5.04214e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.404297; expected ratio = 0.001obtained abs = 150.051; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.799220e+05 Mflops = 365.80 -Solve time = 0.00 -Solve flops = 1.692400e+04 Mflops = 499.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00023745; expected ratio = 0.0001obtained abs = 2.9813e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.266712; expected ratio = 0.001obtained abs = 98.1426; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.799220e+05 Mflops = 365.09 -Solve time = 0.00 -Solve flops = 1.692400e+04 Mflops = 496.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000256433; expected ratio = 0.0001obtained abs = 3.21973e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.217104; expected ratio = 0.001obtained abs = 80.1611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.790820e+05 Mflops = 360.25 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 482.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000137461; expected ratio = 0.0001obtained abs = 1.72583e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.14932; expected ratio = 0.001obtained abs = 54.7851; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.799220e+05 Mflops = 366.33 -Solve time = 0.00 -Solve flops = 1.692400e+04 Mflops = 486.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000159402; expected ratio = 0.0001obtained abs = 2.00128e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123508; expected ratio = 0.001obtained abs = 45.5041; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.790820e+05 Mflops = 364.80 -Solve time = 0.00 -Solve flops = 1.689400e+04 Mflops = 495.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.91551e-05; expected ratio = 0.0001obtained abs = 1.1193e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0893757; expected ratio = 0.001obtained abs = 32.8018; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.4683 - Final Residual ratio : 0.00125743 - Residual ratio : 0.00050943 - Slope : -0.091372 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.36994 - Final Residual ratio : 0.00125168 - Residual ratio : 0.00052815 - Slope : -0.0877293 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.25252 - Final Residual ratio : 0.00146296 - Residual ratio : 0.000649478 - Slope : -0.093794 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 78.3157 - Final Residual ratio : 0.0650357 - Residual ratio : 0.000830429 - Slope : -5.58933 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.6592 - Final Residual ratio : 0.0161009 - Residual ratio : 0.000911755 - Slope : -0.980172 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.4682 - Final Residual ratio : 0.00852557 - Residual ratio : 0.000743409 - Slope : -0.409274 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.12944 - Final Residual ratio : 0.00571894 - Residual ratio : 0.000703485 - Slope : -0.300878 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1631 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.15355 - Final Residual ratio : 0.00576551 - Residual ratio : 0.000707116 - Slope : -0.30177 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.42086 - Final Residual ratio : 0.00628316 - Residual ratio : 0.000746143 - Slope : -0.311651 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.16453 - Final Residual ratio : 0.00785454 - Residual ratio : 0.000962032 - Slope : -0.407834 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 121 - - Mesh vertices: 115 - Mesh triangles: 123 - Mesh edges: 199 - Mesh exterior boundary edges: 29 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 29 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1651 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00048399 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.838230e+05 Mflops = 365.41 -Solve time = 0.00 -Solve flops = 1.726800e+04 Mflops = 479.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0502985; expected ratio = 0.0001obtained abs = 0.000605754; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123884; expected ratio = 0.001obtained abs = 45.0151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000479937 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.855510e+05 Mflops = 370.42 -Solve time = 0.00 -Solve flops = 1.732600e+04 Mflops = 494.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00653071; expected ratio = 0.0001obtained abs = 7.90111e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144159; expected ratio = 0.001obtained abs = 50.9266; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000478983 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.864970e+05 Mflops = 362.14 -Solve time = 0.00 -Solve flops = 1.734000e+04 Mflops = 494.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000839108; expected ratio = 0.0001obtained abs = 1.015e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104781; expected ratio = 0.001obtained abs = 37.5083; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.838450e+05 Mflops = 368.42 -Solve time = 0.00 -Solve flops = 1.728600e+04 Mflops = 493.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000401774; expected ratio = 0.0001obtained abs = 4.86004e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.218376; expected ratio = 0.001obtained abs = 77.2973; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.841550e+05 Mflops = 368.16 -Solve time = 0.00 -Solve flops = 1.727400e+04 Mflops = 479.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000761311; expected ratio = 0.0001obtained abs = 9.20921e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166391; expected ratio = 0.001obtained abs = 59.3047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.834710e+05 Mflops = 361.11 -Solve time = 0.00 -Solve flops = 1.727200e+04 Mflops = 492.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000738775; expected ratio = 0.0001obtained abs = 8.9367e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155428; expected ratio = 0.001obtained abs = 55.005; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.833450e+05 Mflops = 363.08 -Solve time = 0.00 -Solve flops = 1.724400e+04 Mflops = 492.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000398142; expected ratio = 0.0001obtained abs = 4.81627e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.174664; expected ratio = 0.001obtained abs = 62.4514; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000494003 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.835390e+05 Mflops = 367.10 -Solve time = 0.00 -Solve flops = 1.727400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00026811; expected ratio = 0.0001obtained abs = 3.24312e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.246452; expected ratio = 0.001obtained abs = 87.8106; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.849950e+05 Mflops = 370.02 -Solve time = 0.00 -Solve flops = 1.730400e+04 Mflops = 493.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000547242; expected ratio = 0.0001obtained abs = 6.61955e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.24183; expected ratio = 0.001obtained abs = 86.6963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.855330e+05 Mflops = 370.92 -Solve time = 0.00 -Solve flops = 1.732000e+04 Mflops = 368.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000558731; expected ratio = 0.0001obtained abs = 6.75788e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.232958; expected ratio = 0.001obtained abs = 82.7684; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.849950e+05 Mflops = 369.31 -Solve time = 0.00 -Solve flops = 1.730400e+04 Mflops = 493.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000607895; expected ratio = 0.0001obtained abs = 7.35286e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.205027; expected ratio = 0.001obtained abs = 73.2151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.838470e+05 Mflops = 368.42 -Solve time = 0.00 -Solve flops = 1.726000e+04 Mflops = 495.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000563525; expected ratio = 0.0001obtained abs = 6.81562e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155345; expected ratio = 0.001obtained abs = 55.1073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.849950e+05 Mflops = 370.02 -Solve time = 0.00 -Solve flops = 1.730400e+04 Mflops = 493.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000588035; expected ratio = 0.0001obtained abs = 7.11238e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.143891; expected ratio = 0.001obtained abs = 51.2991; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.832310e+05 Mflops = 367.19 -Solve time = 0.00 -Solve flops = 1.726000e+04 Mflops = 492.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000578891; expected ratio = 0.0001obtained abs = 7.00126e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.112053; expected ratio = 0.001obtained abs = 39.8259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.852350e+05 Mflops = 371.20 -Solve time = 0.00 -Solve flops = 1.731600e+04 Mflops = 497.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000348207; expected ratio = 0.0001obtained abs = 4.21135e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117218; expected ratio = 0.001obtained abs = 41.7231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.835390e+05 Mflops = 367.10 -Solve time = 0.00 -Solve flops = 1.727400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000117117; expected ratio = 0.0001obtained abs = 1.41645e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0837518; expected ratio = 0.001obtained abs = 29.7397; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.827290e+05 Mflops = 366.18 -Solve time = 0.00 -Solve flops = 1.724400e+04 Mflops = 505.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.07446e-05; expected ratio = 0.0001obtained abs = 1.09749e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0766208; expected ratio = 0.001obtained abs = 27.2766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.36958 - Final Residual ratio : 0.00733977 - Residual ratio : 0.000995955 - Slope : -0.320098 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.2182 - Final Residual ratio : 0.00484665 - Residual ratio : 0.00077943 - Slope : -0.221905 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.9223 - Final Residual ratio : 0.00397273 - Residual ratio : 0.000807088 - Slope : -0.175655 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.68955 - Final Residual ratio : 0.00367421 - Residual ratio : 0.000995843 - Slope : -0.153578 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.70286 - Final Residual ratio : 0.00254429 - Residual ratio : 0.000941333 - Slope : -0.100012 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.15693 - Final Residual ratio : 0.0016748 - Residual ratio : 0.000776473 - Slope : -0.0718418 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.99606 - Final Residual ratio : 0.0018647 - Residual ratio : 0.000934192 - Slope : -0.0664731 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.39352 - Final Residual ratio : 0.00671283 - Residual ratio : 0.000799764 - Slope : -0.335472 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84023 - Final Residual ratio : 0.00277783 - Residual ratio : 0.00097803 - Slope : -0.0945817 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.53317 - Final Residual ratio : 0.00225209 - Residual ratio : 0.000889042 - Slope : -0.0903898 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 17 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 29 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1751 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.742100e+05 Mflops = 349.11 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 485.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0505461; expected ratio = 0.0001obtained abs = 0.000589341; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104892; expected ratio = 0.001obtained abs = 38.2141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.765300e+05 Mflops = 366.91 -Solve time = 0.00 -Solve flops = 1.695600e+04 Mflops = 483.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00439727; expected ratio = 0.0001obtained abs = 5.13574e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.163726; expected ratio = 0.001obtained abs = 58.5697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.761500e+05 Mflops = 364.67 -Solve time = 0.00 -Solve flops = 1.690600e+04 Mflops = 499.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00211781; expected ratio = 0.0001obtained abs = 2.4716e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138196; expected ratio = 0.001obtained abs = 50.3945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.738160e+05 Mflops = 361.27 -Solve time = 0.00 -Solve flops = 1.686400e+04 Mflops = 498.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000876669; expected ratio = 0.0001obtained abs = 1.0228e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.365327; expected ratio = 0.001obtained abs = 135.211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.745220e+05 Mflops = 362.91 -Solve time = 0.00 -Solve flops = 1.687000e+04 Mflops = 494.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000673004; expected ratio = 0.0001obtained abs = 7.84982e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.312256; expected ratio = 0.001obtained abs = 112.953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.745220e+05 Mflops = 358.30 -Solve time = 0.00 -Solve flops = 1.687000e+04 Mflops = 484.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000607715; expected ratio = 0.0001obtained abs = 7.08713e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.15458; expected ratio = 0.001obtained abs = 56.031; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.751220e+05 Mflops = 363.98 -Solve time = 0.00 -Solve flops = 1.688800e+04 Mflops = 485.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000400398; expected ratio = 0.0001obtained abs = 4.66865e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.210337; expected ratio = 0.001obtained abs = 77.3408; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.736660e+05 Mflops = 361.13 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 494.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000358707; expected ratio = 0.0001obtained abs = 4.182e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.210957; expected ratio = 0.001obtained abs = 76.8084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.753620e+05 Mflops = 364.48 -Solve time = 0.00 -Solve flops = 1.690000e+04 Mflops = 482.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000282421; expected ratio = 0.0001obtained abs = 3.29229e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.154393; expected ratio = 0.001obtained abs = 56.3871; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.736660e+05 Mflops = 361.85 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 497.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000247789; expected ratio = 0.0001obtained abs = 2.88838e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0838013; expected ratio = 0.001obtained abs = 30.5015; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.730960e+05 Mflops = 361.38 -Solve time = 0.00 -Solve flops = 1.684000e+04 Mflops = 480.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000182225; expected ratio = 0.0001obtained abs = 2.124e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0819408; expected ratio = 0.001obtained abs = 29.9345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.736660e+05 Mflops = 361.85 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 494.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000254412; expected ratio = 0.0001obtained abs = 2.96526e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0609968; expected ratio = 0.001obtained abs = 22.2823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.728560e+05 Mflops = 360.70 -Solve time = 0.00 -Solve flops = 1.682800e+04 Mflops = 483.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000156944; expected ratio = 0.0001obtained abs = 1.82911e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0709717; expected ratio = 0.001obtained abs = 25.9293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.736660e+05 Mflops = 360.96 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 494.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000120337; expected ratio = 0.0001obtained abs = 1.40245e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0449634; expected ratio = 0.001obtained abs = 16.4329; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.736660e+05 Mflops = 361.85 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 494.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.64132e-05; expected ratio = 0.0001obtained abs = 7.73983e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0335567; expected ratio = 0.001obtained abs = 12.2662; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0079 - Final Residual ratio : 0.00169812 - Residual ratio : 0.000845717 - Slope : -0.111456 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.90227 - Final Residual ratio : 0.00169242 - Residual ratio : 0.000889686 - Slope : -0.0703917 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.78187 - Final Residual ratio : 0.00157352 - Residual ratio : 0.000883072 - Slope : -0.063582 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65305 - Final Residual ratio : 0.00158097 - Residual ratio : 0.0009564 - Slope : -0.0589809 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51924 - Final Residual ratio : 0.00148839 - Residual ratio : 0.000979695 - Slope : -0.06071 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.45209 - Final Residual ratio : 0.00106825 - Residual ratio : 0.00073566 - Slope : -0.0518222 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40322 - Final Residual ratio : 0.0011899 - Residual ratio : 0.000847973 - Slope : -0.0519272 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37139 - Final Residual ratio : 0.00112644 - Residual ratio : 0.000821388 - Slope : -0.0507504 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34564 - Final Residual ratio : 0.00125633 - Residual ratio : 0.000933631 - Slope : -0.049792 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2905 - Final Residual ratio : 0.00106703 - Residual ratio : 0.000826838 - Slope : -0.0477568 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 15 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1851 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.737510e+05 Mflops = 362.75 -Solve time = 0.00 -Solve flops = 1.683400e+04 Mflops = 493.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0558854; expected ratio = 0.0001obtained abs = 0.000623915; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120077; expected ratio = 0.001obtained abs = 42.8651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.753630e+05 Mflops = 365.21 -Solve time = 0.00 -Solve flops = 1.686000e+04 Mflops = 481.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0118399; expected ratio = 0.0001obtained abs = 0.000133119; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166866; expected ratio = 0.001obtained abs = 57.6787; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.766370e+05 Mflops = 367.13 -Solve time = 0.00 -Solve flops = 1.689600e+04 Mflops = 485.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00153256; expected ratio = 0.0001obtained abs = 1.72197e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116649; expected ratio = 0.001obtained abs = 40.9346; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.735290e+05 Mflops = 362.29 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 493.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000567411; expected ratio = 0.0001obtained abs = 6.37471e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.263985; expected ratio = 0.001obtained abs = 92.7244; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.741450e+05 Mflops = 364.30 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 480.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000794809; expected ratio = 0.0001obtained abs = 8.92893e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.213731; expected ratio = 0.001obtained abs = 74.2899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.743850e+05 Mflops = 364.80 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 480.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000636032; expected ratio = 0.0001obtained abs = 7.14524e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0782566; expected ratio = 0.001obtained abs = 27.1009; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.729590e+05 Mflops = 363.27 -Solve time = 0.00 -Solve flops = 1.680600e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000358753; expected ratio = 0.0001obtained abs = 4.03028e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166235; expected ratio = 0.001obtained abs = 58.6766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.750650e+05 Mflops = 360.29 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 481.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000269388; expected ratio = 0.0001obtained abs = 3.02624e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.320711; expected ratio = 0.001obtained abs = 113.126; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.749850e+05 Mflops = 364.60 -Solve time = 0.00 -Solve flops = 1.685400e+04 Mflops = 480.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000690052; expected ratio = 0.0001obtained abs = 7.75153e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.247482; expected ratio = 0.001obtained abs = 86.4791; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.743850e+05 Mflops = 356.62 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 493.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00060128; expected ratio = 0.0001obtained abs = 6.75435e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125981; expected ratio = 0.001obtained abs = 43.7887; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.752250e+05 Mflops = 365.83 -Solve time = 0.00 -Solve flops = 1.686600e+04 Mflops = 494.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000381464; expected ratio = 0.0001obtained abs = 4.28523e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16019; expected ratio = 0.001obtained abs = 56.2743; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.735290e+05 Mflops = 363.01 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 480.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000281438; expected ratio = 0.0001obtained abs = 3.16145e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.277785; expected ratio = 0.001obtained abs = 98.2795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.749850e+05 Mflops = 366.06 -Solve time = 0.00 -Solve flops = 1.685400e+04 Mflops = 484.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000228616; expected ratio = 0.0001obtained abs = 2.56802e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.267602; expected ratio = 0.001obtained abs = 93.5614; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.735290e+05 Mflops = 362.29 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 496.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000149407; expected ratio = 0.0001obtained abs = 1.67825e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164565; expected ratio = 0.001obtained abs = 57.3839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.749850e+05 Mflops = 366.06 -Solve time = 0.00 -Solve flops = 1.685400e+04 Mflops = 497.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00039384; expected ratio = 0.0001obtained abs = 4.42391e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122881; expected ratio = 0.001obtained abs = 42.8975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.737690e+05 Mflops = 364.42 -Solve time = 0.00 -Solve flops = 1.683600e+04 Mflops = 480.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000398697; expected ratio = 0.0001obtained abs = 4.47839e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0932886; expected ratio = 0.001obtained abs = 32.5033; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.733350e+05 Mflops = 364.06 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 492.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000233396; expected ratio = 0.0001obtained abs = 2.62175e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0993159; expected ratio = 0.001obtained abs = 34.7124; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.735290e+05 Mflops = 362.29 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 496.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000101681; expected ratio = 0.0001obtained abs = 1.14219e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0945027; expected ratio = 0.001obtained abs = 32.9223; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.727190e+05 Mflops = 362.94 -Solve time = 0.00 -Solve flops = 1.679400e+04 Mflops = 479.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000369854; expected ratio = 0.0001obtained abs = 4.1546e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0701778; expected ratio = 0.001obtained abs = 24.4859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.735290e+05 Mflops = 363.19 -Solve time = 0.00 -Solve flops = 1.682400e+04 Mflops = 493.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000380781; expected ratio = 0.0001obtained abs = 4.27728e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0532103; expected ratio = 0.001obtained abs = 18.533; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.301 - Final Residual ratio : 0.000855505 - Residual ratio : 0.000657574 - Slope : -0.0541728 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29497 - Final Residual ratio : 0.00111051 - Residual ratio : 0.000857554 - Slope : -0.0718811 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.28846 - Final Residual ratio : 0.000967232 - Residual ratio : 0.000750686 - Slope : -0.0495191 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27654 - Final Residual ratio : 0.0011292 - Residual ratio : 0.000884578 - Slope : -0.0510165 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22203 - Final Residual ratio : 0.00117718 - Residual ratio : 0.000963295 - Slope : -0.0488341 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1911 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22478 - Final Residual ratio : 0.00121804 - Residual ratio : 0.000994496 - Slope : -0.0531984 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.20278 - Final Residual ratio : 0.00105177 - Residual ratio : 0.000874443 - Slope : -0.0500722 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1931 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4809 - Final Residual ratio : 0.0095119 - Residual ratio : 0.000907547 - Slope : -0.361082 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.4988 - Final Residual ratio : 0.0409196 - Residual ratio : 0.000826678 - Slope : -1.70545 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.6449 - Final Residual ratio : 0.0422927 - Residual ratio : 0.000773956 - Slope : -1.88285 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.1951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.1951 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.719880e+05 Mflops = 359.97 -Solve time = 0.00 -Solve flops = 1.677000e+04 Mflops = 478.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0520664; expected ratio = 0.0001obtained abs = 0.000563269; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120485; expected ratio = 0.001obtained abs = 43.6017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.746880e+05 Mflops = 363.98 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 480.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00650023; expected ratio = 0.0001obtained abs = 7.03713e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.151389; expected ratio = 0.001obtained abs = 53.8585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.753260e+05 Mflops = 364.41 -Solve time = 0.00 -Solve flops = 1.684600e+04 Mflops = 497.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00177298; expected ratio = 0.0001obtained abs = 1.91866e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0923138; expected ratio = 0.001obtained abs = 33.1507; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.738480e+05 Mflops = 362.95 -Solve time = 0.00 -Solve flops = 1.681600e+04 Mflops = 479.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000638646; expected ratio = 0.0001obtained abs = 6.90989e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.13359; expected ratio = 0.001obtained abs = 47.9271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.738480e+05 Mflops = 357.09 -Solve time = 0.00 -Solve flops = 1.681600e+04 Mflops = 493.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000590659; expected ratio = 0.0001obtained abs = 6.38972e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138339; expected ratio = 0.001obtained abs = 49.9778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.731420e+05 Mflops = 353.22 -Solve time = 0.00 -Solve flops = 1.681000e+04 Mflops = 496.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000371836; expected ratio = 0.0001obtained abs = 4.02172e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131625; expected ratio = 0.001obtained abs = 47.3286; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.727980e+05 Mflops = 362.20 -Solve time = 0.00 -Solve flops = 1.677400e+04 Mflops = 478.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000410748; expected ratio = 0.0001obtained abs = 4.44215e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103182; expected ratio = 0.001obtained abs = 37.1931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.729920e+05 Mflops = 362.07 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000300261; expected ratio = 0.0001obtained abs = 3.24681e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0841664; expected ratio = 0.001obtained abs = 30.4088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.721820e+05 Mflops = 360.91 -Solve time = 0.00 -Solve flops = 1.677400e+04 Mflops = 491.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000284937; expected ratio = 0.0001obtained abs = 3.08085e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0732362; expected ratio = 0.001obtained abs = 26.4404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.729920e+05 Mflops = 361.89 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000203024; expected ratio = 0.0001obtained abs = 2.19501e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.040202; expected ratio = 0.001obtained abs = 14.5337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.729920e+05 Mflops = 361.89 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000181287; expected ratio = 0.0001obtained abs = 1.95989e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0267027; expected ratio = 0.001obtained abs = 9.65545; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.729920e+05 Mflops = 361.17 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000241895; expected ratio = 0.0001obtained abs = 2.61496e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0263303; expected ratio = 0.001obtained abs = 9.54396; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.732320e+05 Mflops = 360.95 -Solve time = 0.00 -Solve flops = 1.681600e+04 Mflops = 496.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000309953; expected ratio = 0.0001obtained abs = 3.35045e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0744873; expected ratio = 0.001obtained abs = 27.1024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.732320e+05 Mflops = 362.39 -Solve time = 0.00 -Solve flops = 1.681600e+04 Mflops = 479.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00016654; expected ratio = 0.0001obtained abs = 1.80008e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116439; expected ratio = 0.001obtained abs = 42.1136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.766520e+05 Mflops = 369.54 -Solve time = 0.00 -Solve flops = 1.694600e+04 Mflops = 497.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000115166; expected ratio = 0.0001obtained abs = 1.24478e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0781468; expected ratio = 0.001obtained abs = 28.3416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.738480e+05 Mflops = 362.95 -Solve time = 0.00 -Solve flops = 1.681600e+04 Mflops = 493.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.24857e-05; expected ratio = 0.0001obtained abs = 6.75366e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0378304; expected ratio = 0.001obtained abs = 13.7046; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.1961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.35276 - Final Residual ratio : 0.00573552 - Residual ratio : 0.000780051 - Slope : -0.253346 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.22281 - Final Residual ratio : 0.00793791 - Residual ratio : 0.000860683 - Slope : -0.317754 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 219.227 - Final Residual ratio : 0.211002 - Residual ratio : 0.00096248 - Slope : -9.12567 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.1991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 152.908 - Final Residual ratio : 0.141786 - Residual ratio : 0.000927266 - Slope : -6.36524 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.1991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.4874 - Final Residual ratio : 0.0494002 - Residual ratio : 0.000941182 - Slope : -3.74557 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.3323 - Final Residual ratio : 0.0211819 - Residual ratio : 0.000907838 - Slope : -1.05959 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.0677 - Final Residual ratio : 0.0134272 - Residual ratio : 0.000835663 - Slope : -0.64217 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.5956 - Final Residual ratio : 0.0110203 - Residual ratio : 0.000810576 - Slope : -0.485165 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0623 - Final Residual ratio : 0.0105126 - Residual ratio : 0.000871529 - Slope : -0.43042 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.5272 - Final Residual ratio : 0.00753589 - Residual ratio : 0.000715852 - Slope : -0.375701 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 16 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2051 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.685030e+05 Mflops = 345.26 -Solve time = 0.00 -Solve flops = 1.648000e+04 Mflops = 470.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0576222; expected ratio = 0.0001obtained abs = 0.000598055; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145699; expected ratio = 0.001obtained abs = 52.5857; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.683830e+05 Mflops = 347.91 -Solve time = 0.00 -Solve flops = 1.647000e+04 Mflops = 483.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0104938; expected ratio = 0.0001obtained abs = 0.000109461; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.165075; expected ratio = 0.001obtained abs = 58.0629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.683830e+05 Mflops = 347.05 -Solve time = 0.00 -Solve flops = 1.647000e+04 Mflops = 473.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00299361; expected ratio = 0.0001obtained abs = 3.12038e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11855; expected ratio = 0.001obtained abs = 42.4117; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.683830e+05 Mflops = 347.05 -Solve time = 0.00 -Solve flops = 1.647000e+04 Mflops = 486.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00146491; expected ratio = 0.0001obtained abs = 1.52693e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.217607; expected ratio = 0.001obtained abs = 77.6777; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.683830e+05 Mflops = 347.22 -Solve time = 0.00 -Solve flops = 1.647000e+04 Mflops = 486.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000982118; expected ratio = 0.0001obtained abs = 1.02366e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.181327; expected ratio = 0.001obtained abs = 64.4237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.683830e+05 Mflops = 338.08 -Solve time = 0.00 -Solve flops = 1.647000e+04 Mflops = 486.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00061143; expected ratio = 0.0001obtained abs = 6.37304e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.114876; expected ratio = 0.001obtained abs = 40.7918; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.683830e+05 Mflops = 347.91 -Solve time = 0.00 -Solve flops = 1.647000e+04 Mflops = 469.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000485135; expected ratio = 0.0001obtained abs = 5.05647e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.115961; expected ratio = 0.001obtained abs = 41.0464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.683830e+05 Mflops = 347.91 -Solve time = 0.00 -Solve flops = 1.647000e+04 Mflops = 473.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000353414; expected ratio = 0.0001obtained abs = 3.68351e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0676112; expected ratio = 0.001obtained abs = 23.8838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.690550e+05 Mflops = 348.61 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 484.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000310943; expected ratio = 0.0001obtained abs = 3.24069e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0941327; expected ratio = 0.001obtained abs = 33.5514; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.690550e+05 Mflops = 349.29 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 484.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000251318; expected ratio = 0.0001obtained abs = 2.61928e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0552214; expected ratio = 0.001obtained abs = 19.5907; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.690550e+05 Mflops = 349.29 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 471.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000234755; expected ratio = 0.0001obtained abs = 2.4466e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.046387; expected ratio = 0.001obtained abs = 16.4907; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.690550e+05 Mflops = 349.29 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 484.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000166892; expected ratio = 0.0001obtained abs = 1.73935e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.040808; expected ratio = 0.001obtained abs = 14.4883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.690550e+05 Mflops = 342.88 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 471.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000240201; expected ratio = 0.0001obtained abs = 2.50333e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0538776; expected ratio = 0.001obtained abs = 19.109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.690550e+05 Mflops = 348.61 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 484.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000113149; expected ratio = 0.0001obtained abs = 1.17921e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.054644; expected ratio = 0.001obtained abs = 19.416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.690550e+05 Mflops = 349.29 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 471.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000136769; expected ratio = 0.0001obtained abs = 1.42538e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0552026; expected ratio = 0.001obtained abs = 19.5698; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.690550e+05 Mflops = 349.29 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 487.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.06718e-05; expected ratio = 0.0001obtained abs = 9.44985e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0500653; expected ratio = 0.001obtained abs = 17.777; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.2837 - Final Residual ratio : 0.00838603 - Residual ratio : 0.000903307 - Slope : -0.356743 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.09125 - Final Residual ratio : 0.00690667 - Residual ratio : 0.000853598 - Slope : -0.310936 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2081 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.09743 - Final Residual ratio : 0.00571981 - Residual ratio : 0.000805899 - Slope : -0.262656 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.32044 - Final Residual ratio : 0.00592053 - Residual ratio : 0.000936727 - Slope : -0.242866 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.60463 - Final Residual ratio : 0.00453332 - Residual ratio : 0.000808852 - Slope : -0.215388 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.27704 - Final Residual ratio : 0.00435778 - Residual ratio : 0.0008258 - Slope : -0.202796 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.92105 - Final Residual ratio : 0.00394365 - Residual ratio : 0.000801385 - Slope : -0.175611 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.58285 - Final Residual ratio : 0.00424006 - Residual ratio : 0.000925202 - Slope : -0.1761 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.2624 - Final Residual ratio : 0.00312148 - Residual ratio : 0.00073233 - Slope : -0.163818 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.8419 - Final Residual ratio : 0.0036794 - Residual ratio : 0.000957704 - Slope : -0.153529 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 16 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2151 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.688330e+05 Mflops = 347.98 -Solve time = 0.00 -Solve flops = 1.650400e+04 Mflops = 474.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0577696; expected ratio = 0.0001obtained abs = 0.000582848; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125225; expected ratio = 0.001obtained abs = 44.776; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.685610e+05 Mflops = 342.70 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0112115; expected ratio = 0.0001obtained abs = 0.000113274; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.192292; expected ratio = 0.001obtained abs = 66.7654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.24 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00282393; expected ratio = 0.0001obtained abs = 2.85567e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242352; expected ratio = 0.001obtained abs = 84.7579; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.681490e+05 Mflops = 350.36 -Solve time = 0.00 -Solve flops = 1.645800e+04 Mflops = 486.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00154724; expected ratio = 0.0001obtained abs = 1.56514e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.294233; expected ratio = 0.001obtained abs = 101.961; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.682810e+05 Mflops = 350.63 -Solve time = 0.00 -Solve flops = 1.645800e+04 Mflops = 482.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000675039; expected ratio = 0.0001obtained abs = 6.82914e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.197819; expected ratio = 0.001obtained abs = 68.1269; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.681490e+05 Mflops = 335.68 -Solve time = 0.00 -Solve flops = 1.645800e+04 Mflops = 469.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000412225; expected ratio = 0.0001obtained abs = 4.17067e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100478; expected ratio = 0.001obtained abs = 34.6395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.681490e+05 Mflops = 349.66 -Solve time = 0.00 -Solve flops = 1.645800e+04 Mflops = 469.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000315039; expected ratio = 0.0001obtained abs = 3.18733e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0672802; expected ratio = 0.001obtained abs = 23.1988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.681490e+05 Mflops = 348.97 -Solve time = 0.00 -Solve flops = 1.645800e+04 Mflops = 482.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000259879; expected ratio = 0.0001obtained abs = 2.62928e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.055804; expected ratio = 0.001obtained abs = 19.2259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.681490e+05 Mflops = 350.36 -Solve time = 0.00 -Solve flops = 1.645800e+04 Mflops = 482.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000265463; expected ratio = 0.0001obtained abs = 2.68574e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0641525; expected ratio = 0.001obtained abs = 22.1449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.681490e+05 Mflops = 349.49 -Solve time = 0.00 -Solve flops = 1.645800e+04 Mflops = 486.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000257277; expected ratio = 0.0001obtained abs = 2.60294e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0541042; expected ratio = 0.001obtained abs = 18.668; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000283033; expected ratio = 0.0001obtained abs = 2.8634e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0587842; expected ratio = 0.001obtained abs = 20.387; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000280332; expected ratio = 0.0001obtained abs = 2.83601e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0911095; expected ratio = 0.001obtained abs = 31.4679; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.24 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000293506; expected ratio = 0.0001obtained abs = 2.96931e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0771469; expected ratio = 0.001obtained abs = 26.5237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.55 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000225627; expected ratio = 0.0001obtained abs = 2.28275e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0957476; expected ratio = 0.001obtained abs = 33.15; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000237397; expected ratio = 0.0001obtained abs = 2.40182e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0987808; expected ratio = 0.001obtained abs = 34.0174; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000321587; expected ratio = 0.0001obtained abs = 3.25359e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123038; expected ratio = 0.001obtained abs = 42.626; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00031491; expected ratio = 0.0001obtained abs = 3.18603e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109849; expected ratio = 0.001obtained abs = 37.7904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.55 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00016531; expected ratio = 0.0001obtained abs = 1.67253e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0817607; expected ratio = 0.001obtained abs = 28.3017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.681490e+05 Mflops = 349.66 -Solve time = 0.00 -Solve flops = 1.645800e+04 Mflops = 482.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000169152; expected ratio = 0.0001obtained abs = 1.71137e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0795152; expected ratio = 0.001obtained abs = 27.3762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.681490e+05 Mflops = 349.66 -Solve time = 0.00 -Solve flops = 1.645800e+04 Mflops = 469.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000186497; expected ratio = 0.0001obtained abs = 1.88682e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.086395; expected ratio = 0.001obtained abs = 29.9054; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.69281 - Final Residual ratio : 0.00283341 - Residual ratio : 0.000767279 - Slope : -0.141922 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.14799 - Final Residual ratio : 0.00399884 - Residual ratio : 0.000776777 - Slope : -0.428666 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.74445 - Final Residual ratio : 0.00351105 - Residual ratio : 0.000937668 - Slope : -0.143882 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.19743 - Final Residual ratio : 0.00304179 - Residual ratio : 0.000951325 - Slope : -0.114085 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84154 - Final Residual ratio : 0.00217236 - Residual ratio : 0.000764501 - Slope : -0.101406 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.76354 - Final Residual ratio : 0.00187206 - Residual ratio : 0.000677411 - Slope : -0.0986311 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.63885 - Final Residual ratio : 0.00230635 - Residual ratio : 0.000873999 - Slope : -0.0976496 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.2231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.53025 - Final Residual ratio : 0.00192157 - Residual ratio : 0.000759438 - Slope : -0.158021 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.43535 - Final Residual ratio : 0.00231309 - Residual ratio : 0.000949798 - Slope : -0.0901126 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.24027 - Final Residual ratio : 0.0019401 - Residual ratio : 0.000866012 - Slope : -0.0829011 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2251 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 346.47 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0557956; expected ratio = 0.0001obtained abs = 0.000548705; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109036; expected ratio = 0.001obtained abs = 38.304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.685610e+05 Mflops = 348.96 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00586028; expected ratio = 0.0001obtained abs = 5.76817e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.184338; expected ratio = 0.001obtained abs = 63.7612; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 348.00 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00163626; expected ratio = 0.0001obtained abs = 1.60936e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.161311; expected ratio = 0.001obtained abs = 56.4566; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.38 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000908206; expected ratio = 0.0001obtained abs = 8.93131e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.240008; expected ratio = 0.001obtained abs = 84.5143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000469208 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 339.64 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000614918; expected ratio = 0.0001obtained abs = 6.04606e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.220894; expected ratio = 0.001obtained abs = 77.3668; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.55 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000589556; expected ratio = 0.0001obtained abs = 5.79657e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137925; expected ratio = 0.001obtained abs = 48.2897; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.24 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000472165; expected ratio = 0.0001obtained abs = 4.64215e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104115; expected ratio = 0.001obtained abs = 36.4521; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.38 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 473.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000343676; expected ratio = 0.0001obtained abs = 3.37898e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0537095; expected ratio = 0.001obtained abs = 18.8226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000260355; expected ratio = 0.0001obtained abs = 2.55964e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0485395; expected ratio = 0.001obtained abs = 17.027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.55 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000317991; expected ratio = 0.0001obtained abs = 3.12628e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0591442; expected ratio = 0.001obtained abs = 20.7229; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.38 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000326739; expected ratio = 0.0001obtained abs = 3.21223e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0546554; expected ratio = 0.001obtained abs = 19.1601; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.55 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00027519; expected ratio = 0.0001obtained abs = 2.7055e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0486265; expected ratio = 0.001obtained abs = 17.0476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 473.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000373423; expected ratio = 0.0001obtained abs = 3.67118e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0680505; expected ratio = 0.001obtained abs = 23.8976; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 348.69 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00039178; expected ratio = 0.0001obtained abs = 3.85171e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0625348; expected ratio = 0.001obtained abs = 21.9604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 348.69 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000219602; expected ratio = 0.0001obtained abs = 2.15891e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0477637; expected ratio = 0.001obtained abs = 16.7465; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000205044; expected ratio = 0.0001obtained abs = 2.0158e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0468084; expected ratio = 0.001obtained abs = 16.4241; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000258817; expected ratio = 0.0001obtained abs = 2.54441e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0587945; expected ratio = 0.001obtained abs = 20.6415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.55 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000278975; expected ratio = 0.0001obtained abs = 2.7426e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.05665; expected ratio = 0.001obtained abs = 19.8969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000267256; expected ratio = 0.0001obtained abs = 2.62731e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0604182; expected ratio = 0.001obtained abs = 21.2252; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.55 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000276457; expected ratio = 0.0001obtained abs = 2.71777e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0614496; expected ratio = 0.001obtained abs = 21.5872; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.22846 - Final Residual ratio : 0.00148343 - Residual ratio : 0.000665673 - Slope : -0.0824806 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2271 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.08745 - Final Residual ratio : 0.00593435 - Residual ratio : 0.00097485 - Slope : -0.405434 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.51769 - Final Residual ratio : 0.00195883 - Residual ratio : 0.000778025 - Slope : -0.10938 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05198 - Final Residual ratio : 0.00168434 - Residual ratio : 0.000820838 - Slope : -0.0706998 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8554 - Final Residual ratio : 0.00140348 - Residual ratio : 0.000756428 - Slope : -0.0617999 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2311 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84106 - Final Residual ratio : 0.00137991 - Residual ratio : 0.000749522 - Slope : -0.0613225 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77303 - Final Residual ratio : 0.00135121 - Residual ratio : 0.000762089 - Slope : -0.0590559 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70818 - Final Residual ratio : 0.0014719 - Residual ratio : 0.00086168 - Slope : -0.0682682 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65566 - Final Residual ratio : 0.00165445 - Residual ratio : 0.000999268 - Slope : -0.0661604 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53665 - Final Residual ratio : 0.00119662 - Residual ratio : 0.000778719 - Slope : -0.0548376 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2351 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00048089 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 348.69 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0583814; expected ratio = 0.0001obtained abs = 0.00055644; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0914151; expected ratio = 0.001obtained abs = 32.4445; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.685610e+05 Mflops = 350.52 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00540707; expected ratio = 0.0001obtained abs = 5.16337e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.223798; expected ratio = 0.001obtained abs = 78.1203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0011138; expected ratio = 0.0001obtained abs = 1.06338e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185938; expected ratio = 0.001obtained abs = 65.2136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.38 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000678903; expected ratio = 0.0001obtained abs = 6.48203e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189023; expected ratio = 0.001obtained abs = 66.6667; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.24 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000532122; expected ratio = 0.0001obtained abs = 5.08038e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.202232; expected ratio = 0.001obtained abs = 70.7479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000344552; expected ratio = 0.0001obtained abs = 3.28983e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123457; expected ratio = 0.001obtained abs = 43.2788; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000245896; expected ratio = 0.0001obtained abs = 2.34774e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0957977; expected ratio = 0.001obtained abs = 33.5629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 342.43 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000333911; expected ratio = 0.0001obtained abs = 3.18801e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0884345; expected ratio = 0.001obtained abs = 31.1068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.24 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000408106; expected ratio = 0.0001obtained abs = 3.89621e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106327; expected ratio = 0.001obtained abs = 37.2895; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.24 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000414012; expected ratio = 0.0001obtained abs = 3.95267e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.136802; expected ratio = 0.001obtained abs = 48.5376; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.77 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 473.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000390624; expected ratio = 0.0001obtained abs = 3.72927e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.262776; expected ratio = 0.001obtained abs = 92.3412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000580781; expected ratio = 0.0001obtained abs = 5.54509e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.201321; expected ratio = 0.001obtained abs = 70.5219; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000380147; expected ratio = 0.0001obtained abs = 3.62957e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0930692; expected ratio = 0.001obtained abs = 32.6023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000371367; expected ratio = 0.0001obtained abs = 3.54588e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104894; expected ratio = 0.001obtained abs = 36.6932; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00042745; expected ratio = 0.0001obtained abs = 4.08138e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0922913; expected ratio = 0.001obtained abs = 32.2616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.24 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 470.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000208158; expected ratio = 0.0001obtained abs = 1.98761e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0609198; expected ratio = 0.001obtained abs = 21.3235; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000214417; expected ratio = 0.0001obtained abs = 2.04728e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0522256; expected ratio = 0.001obtained abs = 18.2902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 349.38 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 473.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000250751; expected ratio = 0.0001obtained abs = 2.39416e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0664012; expected ratio = 0.001obtained abs = 23.2348; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 486.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000347465; expected ratio = 0.0001obtained abs = 3.31752e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0852576; expected ratio = 0.001obtained abs = 29.8978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.684290e+05 Mflops = 350.07 -Solve time = 0.00 -Solve flops = 1.647800e+04 Mflops = 483.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000338466; expected ratio = 0.0001obtained abs = 3.2316e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0756927; expected ratio = 0.001obtained abs = 26.5363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.79065 - Final Residual ratio : 0.001144 - Residual ratio : 0.000638871 - Slope : -0.0617072 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.85175 - Final Residual ratio : 0.00167487 - Residual ratio : 0.00090448 - Slope : -0.0685213 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.87355 - Final Residual ratio : 0.00162549 - Residual ratio : 0.000867597 - Slope : -0.0719972 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.79726 - Final Residual ratio : 0.00172537 - Residual ratio : 0.000960003 - Slope : -0.0641261 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63878 - Final Residual ratio : 0.00117408 - Residual ratio : 0.000716433 - Slope : -0.0564692 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56895 - Final Residual ratio : 0.00136091 - Residual ratio : 0.000867402 - Slope : -0.0559855 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48018 - Final Residual ratio : 0.00115394 - Residual ratio : 0.000779596 - Slope : -0.0528222 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40469 - Final Residual ratio : 0.00115245 - Residual ratio : 0.00082043 - Slope : -0.093569 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35145 - Final Residual ratio : 0.0010377 - Residual ratio : 0.00076784 - Slope : -0.0540164 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26131 - Final Residual ratio : 0.00124277 - Residual ratio : 0.000985299 - Slope : -0.0484643 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2451 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.643630e+05 Mflops = 341.11 -Solve time = 0.00 -Solve flops = 1.624400e+04 Mflops = 463.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0599983; expected ratio = 0.0001obtained abs = 0.000556055; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0949726; expected ratio = 0.001obtained abs = 33.6114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.644950e+05 Mflops = 342.06 -Solve time = 0.00 -Solve flops = 1.624400e+04 Mflops = 476.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00638847; expected ratio = 0.0001obtained abs = 5.93428e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.186148; expected ratio = 0.001obtained abs = 65.1125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.643630e+05 Mflops = 341.79 -Solve time = 0.00 -Solve flops = 1.624400e+04 Mflops = 476.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00109471; expected ratio = 0.0001obtained abs = 1.01627e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.182005; expected ratio = 0.001obtained abs = 63.8771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 334.62 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 463.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000558257; expected ratio = 0.0001obtained abs = 5.18204e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127413; expected ratio = 0.001obtained abs = 44.6131; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.25 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 476.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000509906; expected ratio = 0.0001obtained abs = 4.73283e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127546; expected ratio = 0.001obtained abs = 45.1083; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.25 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 463.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000427432; expected ratio = 0.0001obtained abs = 3.96722e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.126494; expected ratio = 0.001obtained abs = 44.363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 343.61 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 480.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000293522; expected ratio = 0.0001obtained abs = 2.7243e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.161115; expected ratio = 0.001obtained abs = 57.3997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.25 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 476.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000442444; expected ratio = 0.0001obtained abs = 4.10648e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.283766; expected ratio = 0.001obtained abs = 99.7234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.93 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 476.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000652475; expected ratio = 0.0001obtained abs = 6.05637e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.219261; expected ratio = 0.001obtained abs = 76.9801; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.76 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 480.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000349633; expected ratio = 0.0001obtained abs = 3.24552e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105941; expected ratio = 0.001obtained abs = 37.1544; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.93 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 480.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000236351; expected ratio = 0.0001obtained abs = 2.19401e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0841139; expected ratio = 0.001obtained abs = 29.4886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.93 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 480.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000259789; expected ratio = 0.0001obtained abs = 2.41154e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0877517; expected ratio = 0.001obtained abs = 30.7452; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.93 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 476.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000326267; expected ratio = 0.0001obtained abs = 3.0286e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101275; expected ratio = 0.001obtained abs = 35.7375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 338.06 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 476.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000286218; expected ratio = 0.0001obtained abs = 2.65677e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.124421; expected ratio = 0.001obtained abs = 43.5659; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.76 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 480.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000356463; expected ratio = 0.0001obtained abs = 3.30882e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.167624; expected ratio = 0.001obtained abs = 59.6541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.25 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 476.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000451506; expected ratio = 0.0001obtained abs = 4.19095e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.257424; expected ratio = 0.001obtained abs = 90.4166; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 343.61 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 463.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000549639; expected ratio = 0.0001obtained abs = 5.1021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.200381; expected ratio = 0.001obtained abs = 70.3465; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.93 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 476.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00033942; expected ratio = 0.0001obtained abs = 3.15073e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123526; expected ratio = 0.001obtained abs = 43.2821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 333.81 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 463.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000295207; expected ratio = 0.0001obtained abs = 2.74042e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107122; expected ratio = 0.001obtained abs = 37.5647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.645830e+05 Mflops = 342.25 -Solve time = 0.00 -Solve flops = 1.626000e+04 Mflops = 476.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000270816; expected ratio = 0.0001obtained abs = 2.51393e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0922449; expected ratio = 0.001obtained abs = 32.3606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.9958 - Final Residual ratio : 0.0268995 - Residual ratio : 0.00084072 - Slope : -1.33204 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.70514 - Final Residual ratio : 0.0087937 - Residual ratio : 0.000906086 - Slope : -0.692596 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.87806 - Final Residual ratio : 0.00812388 - Residual ratio : 0.000915051 - Slope : -0.354797 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.46533 - Final Residual ratio : 0.00784629 - Residual ratio : 0.000926873 - Slope : -0.338299 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.81506 - Final Residual ratio : 0.00599763 - Residual ratio : 0.000767445 - Slope : -0.300349 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.20111 - Final Residual ratio : 0.00686185 - Residual ratio : 0.000952889 - Slope : -0.28777 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.65469 - Final Residual ratio : 0.00512044 - Residual ratio : 0.00076945 - Slope : -0.277065 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.19598 - Final Residual ratio : 0.00617206 - Residual ratio : 0.00099614 - Slope : -0.281355 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.81066 - Final Residual ratio : 0.00524619 - Residual ratio : 0.000902856 - Slope : -0.483785 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.44418 - Final Residual ratio : 0.00532133 - Residual ratio : 0.000977434 - Slope : -0.236472 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2551 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.623780e+05 Mflops = 340.36 -Solve time = 0.00 -Solve flops = 1.615200e+04 Mflops = 464.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0620712; expected ratio = 0.0001obtained abs = 0.000559821; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.255425; expected ratio = 0.001obtained abs = 94.8771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 341.85 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 477.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00565883; expected ratio = 0.0001obtained abs = 5.11249e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.64244; expected ratio = 0.001obtained abs = 230.247; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.637160e+05 Mflops = 344.72 -Solve time = 0.00 -Solve flops = 1.622200e+04 Mflops = 475.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00264322; expected ratio = 0.0001obtained abs = 2.38726e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.413488; expected ratio = 0.001obtained abs = 144.279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.03 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00153825; expected ratio = 0.0001obtained abs = 1.38941e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0922514; expected ratio = 0.001obtained abs = 32.1808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.625700e+05 Mflops = 342.30 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 477.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000614484; expected ratio = 0.0001obtained abs = 5.54922e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0483216; expected ratio = 0.001obtained abs = 16.8472; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.03 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000490609; expected ratio = 0.0001obtained abs = 4.43059e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0414057; expected ratio = 0.001obtained abs = 14.4509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.71 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000474102; expected ratio = 0.0001obtained abs = 4.28121e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0744563; expected ratio = 0.001obtained abs = 26.0281; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 333.00 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000435311; expected ratio = 0.0001obtained abs = 3.93086e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117638; expected ratio = 0.001obtained abs = 41.0289; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.03 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 460.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000561734; expected ratio = 0.0001obtained abs = 5.07252e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119032; expected ratio = 0.001obtained abs = 41.4561; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.71 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000516242; expected ratio = 0.0001obtained abs = 4.66173e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121138; expected ratio = 0.001obtained abs = 42.3036; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 336.95 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 477.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00034205; expected ratio = 0.0001obtained abs = 3.08878e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0784426; expected ratio = 0.001obtained abs = 27.3258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 334.96 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 477.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000319455; expected ratio = 0.0001obtained abs = 2.88465e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0593689; expected ratio = 0.001obtained abs = 20.6783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.03 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000283812; expected ratio = 0.0001obtained abs = 2.56267e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138663; expected ratio = 0.001obtained abs = 48.5516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.71 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000245048; expected ratio = 0.0001obtained abs = 2.21254e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.15562; expected ratio = 0.001obtained abs = 54.4528; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.03 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 460.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000399368; expected ratio = 0.0001obtained abs = 3.60565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134046; expected ratio = 0.001obtained abs = 46.9357; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 340.49 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000226542; expected ratio = 0.0001obtained abs = 2.04519e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.259822; expected ratio = 0.001obtained abs = 91.6283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 341.17 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 477.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000128089; expected ratio = 0.0001obtained abs = 1.15635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.3146; expected ratio = 0.001obtained abs = 111.022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 343.40 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000141459; expected ratio = 0.0001obtained abs = 1.27705e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.28482; expected ratio = 0.001obtained abs = 100.011; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 341.34 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.2558e-05; expected ratio = 0.0001obtained abs = 8.35604e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249407; expected ratio = 0.001obtained abs = 87.6503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.18835 - Final Residual ratio : 0.00454129 - Residual ratio : 0.000875285 - Slope : -0.215992 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.94688 - Final Residual ratio : 0.00468534 - Residual ratio : 0.00094713 - Slope : -0.214878 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.732 - Final Residual ratio : 0.00390085 - Residual ratio : 0.000824354 - Slope : -0.3637 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.54324 - Final Residual ratio : 0.00373098 - Residual ratio : 0.000821216 - Slope : -0.16813 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.33154 - Final Residual ratio : 0.00288951 - Residual ratio : 0.000667086 - Slope : -0.154595 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.21147 - Final Residual ratio : 0.00414781 - Residual ratio : 0.000984885 - Slope : -0.155827 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.07375 - Final Residual ratio : 0.00347329 - Residual ratio : 0.000852603 - Slope : -0.150751 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.93313 - Final Residual ratio : 0.00269462 - Residual ratio : 0.00068511 - Slope : -0.145572 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79656 - Final Residual ratio : 0.00315113 - Residual ratio : 0.000829997 - Slope : -0.158059 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.61772 - Final Residual ratio : 0.00319637 - Residual ratio : 0.00088353 - Slope : -0.301211 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 19 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2651 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 341.34 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 460.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0631535; expected ratio = 0.0001obtained abs = 0.000554287; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.661414; expected ratio = 0.001obtained abs = 358.737; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 336.95 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00533196; expected ratio = 0.0001obtained abs = 4.68563e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.37735; expected ratio = 0.001obtained abs = 1102.25; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.71 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 477.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00103384; expected ratio = 0.0001obtained abs = 9.08245e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.25711; expected ratio = 0.001obtained abs = 810.109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.03 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 460.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000473474; expected ratio = 0.0001obtained abs = 4.15911e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.461576; expected ratio = 0.001obtained abs = 165.016; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.71 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 460.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00033236; expected ratio = 0.0001obtained abs = 2.91947e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.399506; expected ratio = 0.001obtained abs = 141.639; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 341.34 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 460.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000252511; expected ratio = 0.0001obtained abs = 2.21793e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.276589; expected ratio = 0.001obtained abs = 96.8977; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.71 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 460.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000192077; expected ratio = 0.0001obtained abs = 1.68711e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.241415; expected ratio = 0.001obtained abs = 85.2512; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 341.85 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 477.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162854; expected ratio = 0.0001obtained abs = 1.43037e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.182251; expected ratio = 0.001obtained abs = 63.6647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.71 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00012156; expected ratio = 0.0001obtained abs = 1.06768e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.160677; expected ratio = 0.001obtained abs = 56.6126; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.03 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000106029; expected ratio = 0.0001obtained abs = 9.31247e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120648; expected ratio = 0.001obtained abs = 42.1497; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.624380e+05 Mflops = 342.71 -Solve time = 0.00 -Solve flops = 1.615600e+04 Mflops = 473.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.00986e-05; expected ratio = 0.0001obtained abs = 7.03502e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105138; expected ratio = 0.001obtained abs = 36.9883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2661 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.53088 - Final Residual ratio : 0.00298762 - Residual ratio : 0.000846139 - Slope : -0.135688 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.42352 - Final Residual ratio : 0.00279967 - Residual ratio : 0.000817776 - Slope : -0.131566 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.31322 - Final Residual ratio : 0.00324687 - Residual ratio : 0.000979973 - Slope : -0.183887 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.20887 - Final Residual ratio : 0.0030935 - Residual ratio : 0.000964047 - Slope : -0.133574 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.0627 - Final Residual ratio : 0.0030438 - Residual ratio : 0.00099383 - Slope : -0.113321 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 151.363 - Final Residual ratio : 0.131694 - Residual ratio : 0.000870056 - Slope : -6.3013 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.3466 - Final Residual ratio : 0.0613014 - Residual ratio : 0.000910236 - Slope : -2.80356 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.8847 - Final Residual ratio : 0.0206234 - Residual ratio : 0.000767107 - Slope : -1.07456 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.0171 - Final Residual ratio : 0.0169644 - Residual ratio : 0.00094157 - Slope : -0.720007 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.5935 - Final Residual ratio : 0.0122982 - Residual ratio : 0.000842719 - Slope : -1.04151 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 11 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2751 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 338.58 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 458.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0647081; expected ratio = 0.0001obtained abs = 0.000553285; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.645963; expected ratio = 0.001obtained abs = 338.512; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 341.32 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00675369; expected ratio = 0.0001obtained abs = 5.78517e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.36573; expected ratio = 0.001obtained abs = 958.285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 342.18 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00149148; expected ratio = 0.0001obtained abs = 1.27694e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.93705; expected ratio = 0.001obtained abs = 704.529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 342.18 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000372124; expected ratio = 0.0001obtained abs = 3.18579e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.487027; expected ratio = 0.001obtained abs = 173.976; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 342.18 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000416429; expected ratio = 0.0001obtained abs = 3.56536e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.382611; expected ratio = 0.001obtained abs = 135.963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 342.18 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000297651; expected ratio = 0.0001obtained abs = 2.54842e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.26641; expected ratio = 0.001obtained abs = 93.5052; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 342.18 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000481834; expected ratio = 0.0001obtained abs = 4.12566e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.238977; expected ratio = 0.001obtained abs = 84.5762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 336.39 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000509769; expected ratio = 0.0001obtained abs = 4.36503e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.181959; expected ratio = 0.001obtained abs = 63.6494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 342.01 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000655046; expected ratio = 0.0001obtained abs = 5.60952e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.160131; expected ratio = 0.001obtained abs = 56.498; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 341.49 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000596361; expected ratio = 0.0001obtained abs = 5.10728e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121628; expected ratio = 0.001obtained abs = 42.522; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 341.32 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000552895; expected ratio = 0.0001obtained abs = 4.73542e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109173; expected ratio = 0.001obtained abs = 38.447; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 340.63 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000382659; expected ratio = 0.0001obtained abs = 3.27754e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0829057; expected ratio = 0.001obtained abs = 28.9985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 341.49 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00028333; expected ratio = 0.0001obtained abs = 2.42689e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0720564; expected ratio = 0.001obtained abs = 25.3379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 341.32 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00016059; expected ratio = 0.0001obtained abs = 1.37558e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0549211; expected ratio = 0.001obtained abs = 19.2239; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 341.32 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000113712; expected ratio = 0.0001obtained abs = 9.74049e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0460716; expected ratio = 0.001obtained abs = 16.1837; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 340.63 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.96339e-05; expected ratio = 0.0001obtained abs = 5.10824e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0353339; expected ratio = 0.001obtained abs = 12.3756; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.5984 - Final Residual ratio : 0.0125156 - Residual ratio : 0.000993427 - Slope : -0.599328 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.9271 - Final Residual ratio : 0.0100823 - Residual ratio : 0.00092269 - Slope : -0.474651 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.58212 - Final Residual ratio : 0.00696043 - Residual ratio : 0.000726397 - Slope : -0.957516 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.50423 - Final Residual ratio : 0.00735318 - Residual ratio : 0.000864649 - Slope : -0.339875 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.53105 - Final Residual ratio : 0.00718206 - Residual ratio : 0.000953659 - Slope : -0.300955 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.83218 - Final Residual ratio : 0.00599036 - Residual ratio : 0.000876786 - Slope : -0.273047 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.19025 - Final Residual ratio : 0.00571635 - Residual ratio : 0.000923444 - Slope : -0.247381 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.63086 - Final Residual ratio : 0.00523515 - Residual ratio : 0.000929724 - Slope : -0.225025 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.15908 - Final Residual ratio : 0.00421955 - Residual ratio : 0.000817888 - Slope : -0.206194 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2851 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.69509 - Final Residual ratio : 0.00361153 - Residual ratio : 0.000769214 - Slope : -0.187659 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 16 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 122 - - Mesh vertices: 115 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2851 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 331.61 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 458.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0646923; expected ratio = 0.0001obtained abs = 0.000541246; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.606616; expected ratio = 0.001obtained abs = 289.108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 336.39 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00611886; expected ratio = 0.0001obtained abs = 5.12616e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.29693; expected ratio = 0.001obtained abs = 790.04; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 340.63 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00131319; expected ratio = 0.0001obtained abs = 1.09996e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.66647; expected ratio = 0.001obtained abs = 606.923; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 340.63 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000650147; expected ratio = 0.0001obtained abs = 5.44563e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.536635; expected ratio = 0.001obtained abs = 191.434; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 341.32 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000371694; expected ratio = 0.0001obtained abs = 3.11319e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.421443; expected ratio = 0.001obtained abs = 148.821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 341.32 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000319293; expected ratio = 0.0001obtained abs = 2.67415e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.287783; expected ratio = 0.001obtained abs = 100.275; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 342.18 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 471.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000220405; expected ratio = 0.0001obtained abs = 1.84593e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.246601; expected ratio = 0.001obtained abs = 86.6549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 340.63 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000196657; expected ratio = 0.0001obtained abs = 1.64699e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185005; expected ratio = 0.001obtained abs = 64.2677; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 342.01 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000142655; expected ratio = 0.0001obtained abs = 1.19473e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.163242; expected ratio = 0.001obtained abs = 57.2244; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 341.32 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 458.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000131302; expected ratio = 0.0001obtained abs = 1.09962e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122711; expected ratio = 0.001obtained abs = 42.6296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.611260e+05 Mflops = 340.63 -Solve time = 0.00 -Solve flops = 1.607600e+04 Mflops = 474.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.09122e-05; expected ratio = 0.0001obtained abs = 7.61369e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108815; expected ratio = 0.001obtained abs = 38.0904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.43176 - Final Residual ratio : 0.00409569 - Residual ratio : 0.000924166 - Slope : -0.192507 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.16368 - Final Residual ratio : 0.00342387 - Residual ratio : 0.000822317 - Slope : -0.16641 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.90958 - Final Residual ratio : 0.00269671 - Residual ratio : 0.000689768 - Slope : -0.156275 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.65602 - Final Residual ratio : 0.00272781 - Residual ratio : 0.000746113 - Slope : -0.281023 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.34926 - Final Residual ratio : 0.00277513 - Residual ratio : 0.00082858 - Slope : -0.119517 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.16012 - Final Residual ratio : 0.0022653 - Residual ratio : 0.000716842 - Slope : -0.108891 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.95715 - Final Residual ratio : 0.00220906 - Residual ratio : 0.000747021 - Slope : -0.101895 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.76868 - Final Residual ratio : 0.00272977 - Residual ratio : 0.000985946 - Slope : -0.0987839 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.60669 - Final Residual ratio : 0.00258948 - Residual ratio : 0.000993395 - Slope : -0.0964483 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.42233 - Final Residual ratio : 0.00222608 - Residual ratio : 0.000918983 - Slope : -0.0930809 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.2951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 11 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 113 - Mesh triangles: 118 - Mesh edges: 192 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.2951 -matrix_partition : [5](0,47,94,141,191) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514430e+05 Mflops = 332.74 -Solve time = 0.00 -Solve flops = 1.526600e+04 Mflops = 477.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0833545; expected ratio = 0.0001obtained abs = 0.000649157; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.58042; expected ratio = 0.001obtained abs = 277.777; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514430e+05 Mflops = 334.31 -Solve time = 0.00 -Solve flops = 1.526600e+04 Mflops = 492.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0136947; expected ratio = 0.0001obtained abs = 0.000106743; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.31539; expected ratio = 0.001obtained abs = 720.245; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514430e+05 Mflops = 334.31 -Solve time = 0.00 -Solve flops = 1.526600e+04 Mflops = 477.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00336883; expected ratio = 0.0001obtained abs = 2.62272e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.42238; expected ratio = 0.001obtained abs = 509.551; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.540410e+05 Mflops = 339.16 -Solve time = 0.00 -Solve flops = 1.536800e+04 Mflops = 481.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000603329; expected ratio = 0.0001obtained abs = 4.69746e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.382201; expected ratio = 0.001obtained abs = 134.179; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.540410e+05 Mflops = 340.05 -Solve time = 0.00 -Solve flops = 1.536800e+04 Mflops = 481.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000664719; expected ratio = 0.0001obtained abs = 5.1759e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.296558; expected ratio = 0.001obtained abs = 104.434; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.540410e+05 Mflops = 340.05 -Solve time = 0.00 -Solve flops = 1.536800e+04 Mflops = 481.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000347013; expected ratio = 0.0001obtained abs = 2.7023e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.210163; expected ratio = 0.001obtained abs = 73.0133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.540410e+05 Mflops = 340.05 -Solve time = 0.00 -Solve flops = 1.536800e+04 Mflops = 481.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000406072; expected ratio = 0.0001obtained abs = 3.16252e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.183338; expected ratio = 0.001obtained abs = 64.2598; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.540410e+05 Mflops = 334.07 -Solve time = 0.00 -Solve flops = 1.536800e+04 Mflops = 481.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000238125; expected ratio = 0.0001obtained abs = 1.85466e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138639; expected ratio = 0.001obtained abs = 48.0836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.540410e+05 Mflops = 340.05 -Solve time = 0.00 -Solve flops = 1.536800e+04 Mflops = 481.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000249566; expected ratio = 0.0001obtained abs = 1.94388e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122933; expected ratio = 0.001obtained abs = 42.9767; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.540410e+05 Mflops = 331.16 -Solve time = 0.00 -Solve flops = 1.536800e+04 Mflops = 467.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000143711; expected ratio = 0.0001obtained abs = 1.1194e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0942886; expected ratio = 0.001obtained abs = 32.7122; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.540410e+05 Mflops = 340.05 -Solve time = 0.00 -Solve flops = 1.536800e+04 Mflops = 477.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000149436; expected ratio = 0.0001obtained abs = 1.16402e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0838245; expected ratio = 0.001obtained abs = 29.2617; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.540410e+05 Mflops = 340.05 -Solve time = 0.00 -Solve flops = 1.536800e+04 Mflops = 481.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.85269e-05; expected ratio = 0.0001obtained abs = 6.89583e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0647195; expected ratio = 0.001obtained abs = 22.4706; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.2961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.12104 - Final Residual ratio : 0.00498574 - Residual ratio : 0.000973578 - Slope : -0.204642 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.37179 - Final Residual ratio : 0.00871274 - Residual ratio : 0.000929676 - Slope : -0.334396 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.7827 - Final Residual ratio : 0.0101307 - Residual ratio : 0.000939528 - Slope : -0.398984 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.2991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0467 - Final Residual ratio : 0.0096292 - Residual ratio : 0.000958448 - Slope : -0.401481 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.2991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.26948 - Final Residual ratio : 0.00796423 - Residual ratio : 0.000963088 - Slope : -0.34423 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.48502 - Final Residual ratio : 0.00582043 - Residual ratio : 0.00089752 - Slope : -0.259168 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.32751 - Final Residual ratio : 0.00522843 - Residual ratio : 0.000981402 - Slope : -0.204703 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.77219 - Final Residual ratio : 0.00377818 - Residual ratio : 0.000791707 - Slope : -0.176608 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.37442 - Final Residual ratio : 0.00374368 - Residual ratio : 0.000855812 - Slope : -0.174827 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.89007 - Final Residual ratio : 0.00312453 - Residual ratio : 0.000803205 - Slope : -0.134033 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 12 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 113 - Mesh triangles: 118 - Mesh edges: 192 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3051 -matrix_partition : [5](0,47,94,141,191) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525350e+05 Mflops = 330.12 -Solve time = 0.00 -Solve flops = 1.534400e+04 Mflops = 466.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0806868; expected ratio = 0.0001obtained abs = 0.000612654; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.54665; expected ratio = 0.001obtained abs = 226.512; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548390e+05 Mflops = 336.50 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 469.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0162996; expected ratio = 0.0001obtained abs = 0.000124217; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.2048; expected ratio = 0.001obtained abs = 556.893; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560390e+05 Mflops = 337.71 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 470.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00191852; expected ratio = 0.0001obtained abs = 1.46176e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.2032; expected ratio = 0.001obtained abs = 399.161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560570e+05 Mflops = 340.03 -Solve time = 0.00 -Solve flops = 1.547600e+04 Mflops = 470.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00247932; expected ratio = 0.0001obtained abs = 1.88923e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.347426; expected ratio = 0.001obtained abs = 113.557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560570e+05 Mflops = 340.03 -Solve time = 0.00 -Solve flops = 1.547600e+04 Mflops = 466.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00845266; expected ratio = 0.0001obtained abs = 6.44071e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.296047; expected ratio = 0.001obtained abs = 96.9623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560570e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.547600e+04 Mflops = 466.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00186203; expected ratio = 0.0001obtained abs = 1.41889e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.213596; expected ratio = 0.001obtained abs = 69.1067; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560570e+05 Mflops = 332.09 -Solve time = 0.00 -Solve flops = 1.547600e+04 Mflops = 466.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00135334; expected ratio = 0.0001obtained abs = 1.03138e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.200211; expected ratio = 0.001obtained abs = 65.2834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.547370e+05 Mflops = 335.75 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 465.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0176576; expected ratio = 0.0001obtained abs = 0.000134505; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155578; expected ratio = 0.001obtained abs = 50.1975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.547370e+05 Mflops = 336.45 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 469.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0097245; expected ratio = 0.0001obtained abs = 7.41102e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.133025; expected ratio = 0.001obtained abs = 43.2509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.559550e+05 Mflops = 339.63 -Solve time = 0.00 -Solve flops = 1.547600e+04 Mflops = 470.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00214771; expected ratio = 0.0001obtained abs = 1.63704e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107306; expected ratio = 0.001obtained abs = 34.6065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560570e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.547600e+04 Mflops = 470.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00126799; expected ratio = 0.0001obtained abs = 9.66668e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0952926; expected ratio = 0.001obtained abs = 30.9386; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560570e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.547600e+04 Mflops = 484.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000698427; expected ratio = 0.0001obtained abs = 5.32464e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0727642; expected ratio = 0.001obtained abs = 23.4932; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560570e+05 Mflops = 340.03 -Solve time = 0.00 -Solve flops = 1.547600e+04 Mflops = 466.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000348291; expected ratio = 0.0001obtained abs = 2.65525e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0629175; expected ratio = 0.001obtained abs = 20.4077; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548390e+05 Mflops = 335.80 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 469.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00016074; expected ratio = 0.0001obtained abs = 1.22541e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0494986; expected ratio = 0.001obtained abs = 15.9949; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548390e+05 Mflops = 336.67 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 469.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.54071e-05; expected ratio = 0.0001obtained abs = 7.27343e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0421671; expected ratio = 0.001obtained abs = 13.6683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.39861 - Final Residual ratio : 0.00318831 - Residual ratio : 0.000938123 - Slope : -0.125756 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.08836 - Final Residual ratio : 0.00279397 - Residual ratio : 0.000904677 - Slope : -0.11428 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.98716 - Final Residual ratio : 0.00170838 - Residual ratio : 0.000571906 - Slope : -0.102947 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.95149 - Final Residual ratio : 0.00262881 - Residual ratio : 0.000890672 - Slope : -0.109217 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.85932 - Final Residual ratio : 0.00223435 - Residual ratio : 0.000781427 - Slope : -0.105818 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.72598 - Final Residual ratio : 0.00207572 - Residual ratio : 0.000761458 - Slope : -0.0972824 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.61058 - Final Residual ratio : 0.00241692 - Residual ratio : 0.000925816 - Slope : -0.16301 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.54467 - Final Residual ratio : 0.00239641 - Residual ratio : 0.000941738 - Slope : -0.0941582 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.48492 - Final Residual ratio : 0.00136268 - Residual ratio : 0.000548377 - Slope : -0.0886986 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3151 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.38811 - Final Residual ratio : 0.00163461 - Residual ratio : 0.000684481 - Slope : -0.0852312 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 15 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 113 - Mesh triangles: 118 - Mesh edges: 192 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3151 -matrix_partition : [5](0,47,94,141,191) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 326.74 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 455.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.07738; expected ratio = 0.0001obtained abs = 0.000582627; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.479713; expected ratio = 0.001obtained abs = 199.129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 333.11 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 463.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0156626; expected ratio = 0.0001obtained abs = 0.000117442; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.11151; expected ratio = 0.001obtained abs = 474.102; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 333.11 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 463.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00415576; expected ratio = 0.0001obtained abs = 3.11231e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.922678; expected ratio = 0.001obtained abs = 324.182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 333.11 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 476.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00201023; expected ratio = 0.0001obtained abs = 1.50464e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.289639; expected ratio = 0.001obtained abs = 101.04; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 333.11 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 463.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00105745; expected ratio = 0.0001obtained abs = 7.91196e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.275994; expected ratio = 0.001obtained abs = 97.382; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 332.42 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 466.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0012167; expected ratio = 0.0001obtained abs = 9.10095e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.257962; expected ratio = 0.001obtained abs = 90.3543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 332.42 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 463.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000647598; expected ratio = 0.0001obtained abs = 4.84332e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.252684; expected ratio = 0.001obtained abs = 89.328; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 326.65 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 466.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0010235; expected ratio = 0.0001obtained abs = 7.65297e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.222879; expected ratio = 0.001obtained abs = 78.0798; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 332.42 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 463.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000911758; expected ratio = 0.0001obtained abs = 6.81668e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185814; expected ratio = 0.001obtained abs = 65.4653; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 331.73 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 466.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00133598; expected ratio = 0.0001obtained abs = 9.98659e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127724; expected ratio = 0.001obtained abs = 44.6516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 332.25 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 466.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00132967; expected ratio = 0.0001obtained abs = 9.93795e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104537; expected ratio = 0.001obtained abs = 36.7674; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 332.42 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 466.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000930462; expected ratio = 0.0001obtained abs = 6.95364e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0782857; expected ratio = 0.001obtained abs = 27.3859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 332.25 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 466.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000520792; expected ratio = 0.0001obtained abs = 3.89191e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0678899; expected ratio = 0.001obtained abs = 23.8563; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 332.42 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 466.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000243837; expected ratio = 0.0001obtained abs = 1.8222e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0508081; expected ratio = 0.001obtained abs = 17.7862; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 331.73 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 480.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000114846; expected ratio = 0.0001obtained abs = 8.58248e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0423228; expected ratio = 0.001obtained abs = 14.8603; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 331.73 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 466.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.17001e-05; expected ratio = 0.0001obtained abs = 5.35822e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0316731; expected ratio = 0.001obtained abs = 11.0941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.24511 - Final Residual ratio : 0.00166977 - Residual ratio : 0.000743736 - Slope : -0.0897377 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11987 - Final Residual ratio : 0.00154002 - Residual ratio : 0.000726469 - Slope : -0.0882639 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3181 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.04077 - Final Residual ratio : 0.00190894 - Residual ratio : 0.000935405 - Slope : -0.0703055 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.9873 - Final Residual ratio : 0.000942706 - Residual ratio : 0.000474365 - Slope : -0.068495 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.92163 - Final Residual ratio : 0.00112293 - Residual ratio : 0.000584363 - Slope : -0.0662242 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8579 - Final Residual ratio : 0.00118398 - Residual ratio : 0.000637267 - Slope : -0.0640247 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82527 - Final Residual ratio : 0.0012278 - Residual ratio : 0.000672665 - Slope : -0.062898 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84093 - Final Residual ratio : 0.00145151 - Residual ratio : 0.000788462 - Slope : -0.0656958 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.3241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.86566 - Final Residual ratio : 0.000998544 - Residual ratio : 0.000535224 - Slope : -0.0665949 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84302 - Final Residual ratio : 0.00112679 - Residual ratio : 0.000611382 - Slope : -0.0657819 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 16 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 113 - Mesh triangles: 118 - Mesh edges: 192 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3251 -matrix_partition : [5](0,47,94,141,191) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.525650e+05 Mflops = 330.87 -Solve time = 0.00 -Solve flops = 1.534600e+04 Mflops = 453.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0869358; expected ratio = 0.0001obtained abs = 0.000636988; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.474335; expected ratio = 0.001obtained abs = 189.84; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560870e+05 Mflops = 340.80 -Solve time = 0.00 -Solve flops = 1.547800e+04 Mflops = 467.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0179981; expected ratio = 0.0001obtained abs = 0.000132448; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.08844; expected ratio = 0.001obtained abs = 431.972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.560690e+05 Mflops = 339.17 -Solve time = 0.00 -Solve flops = 1.548400e+04 Mflops = 470.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00416351; expected ratio = 0.0001obtained abs = 3.06193e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.862341; expected ratio = 0.001obtained abs = 288.052; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 331.75 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 452.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000876651; expected ratio = 0.0001obtained abs = 6.44796e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.265195; expected ratio = 0.001obtained abs = 87.4088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 336.74 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 465.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00066108; expected ratio = 0.0001obtained abs = 4.8629e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.239795; expected ratio = 0.001obtained abs = 79.5679; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.26 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 469.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000330876; expected ratio = 0.0001obtained abs = 2.43407e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185546; expected ratio = 0.001obtained abs = 60.8157; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 338.14 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 469.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000369348; expected ratio = 0.0001obtained abs = 2.71732e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.162917; expected ratio = 0.001obtained abs = 53.8321; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.44 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 465.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000234362; expected ratio = 0.0001obtained abs = 1.72427e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129353; expected ratio = 0.001obtained abs = 42.3451; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.44 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 469.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000272014; expected ratio = 0.0001obtained abs = 2.00139e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117941; expected ratio = 0.001obtained abs = 38.8859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.26 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 469.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000190887; expected ratio = 0.0001obtained abs = 1.4045e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0990039; expected ratio = 0.001obtained abs = 32.415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 338.14 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 465.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000223549; expected ratio = 0.0001obtained abs = 1.64486e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0913014; expected ratio = 0.001obtained abs = 30.0599; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 336.74 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 465.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000180687; expected ratio = 0.0001obtained abs = 1.32949e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.082038; expected ratio = 0.001obtained abs = 26.8745; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 336.56 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 469.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000203388; expected ratio = 0.0001obtained abs = 1.49654e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.077604; expected ratio = 0.001obtained abs = 25.5248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.44 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 465.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000181804; expected ratio = 0.0001obtained abs = 1.33773e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0741411; expected ratio = 0.001obtained abs = 24.3009; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.26 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 469.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000195916; expected ratio = 0.0001obtained abs = 1.44157e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0726252; expected ratio = 0.001obtained abs = 23.8719; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.44 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 465.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00018586; expected ratio = 0.0001obtained abs = 1.36757e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0720095; expected ratio = 0.001obtained abs = 23.6127; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.26 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 469.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000194335; expected ratio = 0.0001obtained abs = 1.42993e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0720295; expected ratio = 0.001obtained abs = 23.6667; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.44 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 469.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000190289; expected ratio = 0.0001obtained abs = 1.40016e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0725065; expected ratio = 0.001obtained abs = 23.7835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 337.26 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 469.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000195401; expected ratio = 0.0001obtained abs = 1.43777e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0730844; expected ratio = 0.001obtained abs = 24.0073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.548690e+05 Mflops = 336.04 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 465.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000194427; expected ratio = 0.0001obtained abs = 1.43061e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0738968; expected ratio = 0.001obtained abs = 24.2454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.77282 - Final Residual ratio : 0.00130354 - Residual ratio : 0.000735293 - Slope : -0.0632684 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67929 - Final Residual ratio : 0.00127439 - Residual ratio : 0.000758885 - Slope : -0.0645391 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61175 - Final Residual ratio : 0.00108683 - Residual ratio : 0.000674314 - Slope : -0.0536889 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57858 - Final Residual ratio : 0.000764323 - Residual ratio : 0.000484185 - Slope : -0.0525937 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.54542 - Final Residual ratio : 0.00142686 - Residual ratio : 0.000923288 - Slope : -0.053241 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50712 - Final Residual ratio : 0.00124654 - Residual ratio : 0.000827101 - Slope : -0.0519268 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.46513 - Final Residual ratio : 0.0011962 - Residual ratio : 0.000816446 - Slope : -0.0504806 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.45373 - Final Residual ratio : 0.00138599 - Residual ratio : 0.000953405 - Slope : -0.0500808 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47429 - Final Residual ratio : 0.00109624 - Residual ratio : 0.000743568 - Slope : -0.0526141 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48507 - Final Residual ratio : 0.00101671 - Residual ratio : 0.000684623 - Slope : -0.0530018 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 191 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3351 -matrix_partition : [5](0,47,94,141,191) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.537320e+05 Mflops = 334.27 -Solve time = 0.00 -Solve flops = 1.535200e+04 Mflops = 450.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0783441; expected ratio = 0.0001obtained abs = 0.00057293; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.396571; expected ratio = 0.001obtained abs = 151.435; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 333.58 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 463.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0108873; expected ratio = 0.0001obtained abs = 7.93994e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.890199; expected ratio = 0.001obtained abs = 330.439; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.71 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00268675; expected ratio = 0.0001obtained abs = 1.95834e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.627532; expected ratio = 0.001obtained abs = 214.064; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.71 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 463.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00110567; expected ratio = 0.0001obtained abs = 8.05692e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.199989; expected ratio = 0.001obtained abs = 67.8654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 334.28 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000682388; expected ratio = 0.0001obtained abs = 4.9714e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.201469; expected ratio = 0.001obtained abs = 68.8793; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 333.40 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 463.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000526353; expected ratio = 0.0001obtained abs = 3.83405e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.149269; expected ratio = 0.001obtained abs = 50.627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 333.40 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000328805; expected ratio = 0.0001obtained abs = 2.39489e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.128489; expected ratio = 0.001obtained abs = 43.922; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 333.58 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 463.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000308034; expected ratio = 0.0001obtained abs = 2.24344e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0936124; expected ratio = 0.001obtained abs = 31.8042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.71 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000195319; expected ratio = 0.0001obtained abs = 1.42248e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0822716; expected ratio = 0.001obtained abs = 28.1158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.88 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000195652; expected ratio = 0.0001obtained abs = 1.42485e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0609235; expected ratio = 0.001obtained abs = 20.7306; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 333.40 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000238843; expected ratio = 0.0001obtained abs = 1.73937e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0535332; expected ratio = 0.001obtained abs = 18.2925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.71 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000177722; expected ratio = 0.0001obtained abs = 1.2942e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0488658; expected ratio = 0.001obtained abs = 16.6481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.71 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000127292; expected ratio = 0.0001obtained abs = 9.26948e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0464594; expected ratio = 0.001obtained abs = 15.8739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.71 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 463.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000147084; expected ratio = 0.0001obtained abs = 1.07106e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0456227; expected ratio = 0.001obtained abs = 15.553; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.71 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000116965; expected ratio = 0.0001obtained abs = 8.51729e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0455107; expected ratio = 0.001obtained abs = 15.5475; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.01 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000138417; expected ratio = 0.0001obtained abs = 1.00794e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0468457; expected ratio = 0.001obtained abs = 15.9755; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.18 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 474.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000124535; expected ratio = 0.0001obtained abs = 9.06848e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0478102; expected ratio = 0.001obtained abs = 16.3307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 333.58 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 460.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000141309; expected ratio = 0.0001obtained abs = 1.029e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0501195; expected ratio = 0.001obtained abs = 17.0955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 332.71 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 463.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000137128; expected ratio = 0.0001obtained abs = 9.98544e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0515292; expected ratio = 0.001obtained abs = 17.5992; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 191 -RHS size in solver: 191 -Factor time = 0.00 -Factor flops = 1.514280e+05 Mflops = 333.40 -Solve time = 0.00 -Solve flops = 1.526200e+04 Mflops = 477.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000149884; expected ratio = 0.0001obtained abs = 1.09145e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0543664; expected ratio = 0.001obtained abs = 18.5464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.46013 - Final Residual ratio : 0.00128369 - Residual ratio : 0.000879159 - Slope : -0.0521018 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41363 - Final Residual ratio : 0.00108202 - Residual ratio : 0.000765417 - Slope : -0.0487086 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36218 - Final Residual ratio : 0.00102865 - Residual ratio : 0.00075515 - Slope : -0.0486125 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32283 - Final Residual ratio : 0.000954012 - Residual ratio : 0.00072119 - Slope : -0.0440626 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.3094 - Final Residual ratio : 0.000743112 - Residual ratio : 0.000567522 - Slope : -0.0436218 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27903 - Final Residual ratio : 0.000608906 - Residual ratio : 0.000476068 - Slope : -0.0426141 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24879 - Final Residual ratio : 0.000565061 - Residual ratio : 0.000452488 - Slope : -0.0416074 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22637 - Final Residual ratio : 0.00122559 - Residual ratio : 0.000999365 - Slope : -0.0422464 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22434 - Final Residual ratio : 0.000849889 - Residual ratio : 0.000694158 - Slope : -0.0719703 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.25113 - Final Residual ratio : 0.000758275 - Residual ratio : 0.000606073 - Slope : -0.0431162 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 114 - Mesh triangles: 119 - Mesh edges: 194 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3451 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609130e+05 Mflops = 334.45 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 471.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0824408; expected ratio = 0.0001obtained abs = 0.000593233; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.369782; expected ratio = 0.001obtained abs = 135.74; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.658370e+05 Mflops = 343.32 -Solve time = 0.00 -Solve flops = 1.615800e+04 Mflops = 477.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.012604; expected ratio = 0.0001obtained abs = 9.07662e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.81776; expected ratio = 0.001obtained abs = 284.903; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.661310e+05 Mflops = 343.25 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 491.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00302111; expected ratio = 0.0001obtained abs = 2.17422e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.543584; expected ratio = 0.001obtained abs = 179.074; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.661310e+05 Mflops = 334.20 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 474.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000907454; expected ratio = 0.0001obtained abs = 6.5309e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.206375; expected ratio = 0.001obtained abs = 67.607; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 477.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000540267; expected ratio = 0.0001obtained abs = 3.88835e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.215958; expected ratio = 0.001obtained abs = 70.9691; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 477.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000265098; expected ratio = 0.0001obtained abs = 1.90798e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.160695; expected ratio = 0.001obtained abs = 52.3769; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 341.72 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 487.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000289526; expected ratio = 0.0001obtained abs = 2.08387e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.14292; expected ratio = 0.001obtained abs = 46.8725; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 477.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000242692; expected ratio = 0.0001obtained abs = 1.7468e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119257; expected ratio = 0.001obtained abs = 38.8672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.74 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 477.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000276209; expected ratio = 0.0001obtained abs = 1.98807e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.112358; expected ratio = 0.001obtained abs = 36.7988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 477.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000262343; expected ratio = 0.0001obtained abs = 1.88828e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106831; expected ratio = 0.001obtained abs = 34.8397; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 491.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000286697; expected ratio = 0.0001obtained abs = 2.06359e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105417; expected ratio = 0.001obtained abs = 34.4972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 477.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000286165; expected ratio = 0.0001obtained abs = 2.05976e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107755; expected ratio = 0.001obtained abs = 35.1654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.74 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 474.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000305395; expected ratio = 0.0001obtained abs = 2.19818e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109348; expected ratio = 0.001obtained abs = 35.7664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 487.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000311391; expected ratio = 0.0001obtained abs = 2.24135e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.114705; expected ratio = 0.001obtained abs = 37.4569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 474.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000327714; expected ratio = 0.0001obtained abs = 2.35883e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117543; expected ratio = 0.001obtained abs = 38.4374; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 342.90 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 477.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000336948; expected ratio = 0.0001obtained abs = 2.42531e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123939; expected ratio = 0.001obtained abs = 40.4954; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.74 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 477.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000351604; expected ratio = 0.0001obtained abs = 2.53079e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127173; expected ratio = 0.001obtained abs = 41.5825; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.07 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 474.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000396865; expected ratio = 0.0001obtained abs = 2.85658e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11518; expected ratio = 0.001obtained abs = 37.6205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 343.74 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 477.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000274943; expected ratio = 0.0001obtained abs = 1.979e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1006; expected ratio = 0.001obtained abs = 32.8524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 342.90 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 491.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000187634; expected ratio = 0.0001obtained abs = 1.35058e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0755298; expected ratio = 0.001obtained abs = 24.6593; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24385 - Final Residual ratio : 0.000699863 - Residual ratio : 0.000562659 - Slope : -0.0428672 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22445 - Final Residual ratio : 0.000790984 - Residual ratio : 0.000645988 - Slope : -0.0421953 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19003 - Final Residual ratio : 0.00104299 - Residual ratio : 0.000876443 - Slope : -0.0440365 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15532 - Final Residual ratio : 0.00105558 - Residual ratio : 0.000913675 - Slope : -0.0461704 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14563 - Final Residual ratio : 0.000783392 - Residual ratio : 0.000683809 - Slope : -0.0381616 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11702 - Final Residual ratio : 0.000607655 - Residual ratio : 0.000543998 - Slope : -0.0372137 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09798 - Final Residual ratio : 0.000527713 - Residual ratio : 0.000480622 - Slope : -0.0365817 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08083 - Final Residual ratio : 0.000552442 - Residual ratio : 0.000511128 - Slope : -0.0360092 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07151 - Final Residual ratio : 0.000845348 - Residual ratio : 0.000788931 - Slope : -0.0356888 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08817 - Final Residual ratio : 0.000718694 - Residual ratio : 0.000660461 - Slope : -0.040276 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 114 - Mesh triangles: 119 - Mesh edges: 194 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3551 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.660410e+05 Mflops = 337.42 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 461.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0785591; expected ratio = 0.0001obtained abs = 0.000567174; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.309831; expected ratio = 0.001obtained abs = 110.933; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.640990e+05 Mflops = 343.97 -Solve time = 0.00 -Solve flops = 1.608800e+04 Mflops = 475.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00797963; expected ratio = 0.0001obtained abs = 5.74604e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.649463; expected ratio = 0.001obtained abs = 221.003; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.612150e+05 Mflops = 336.58 -Solve time = 0.00 -Solve flops = 1.597600e+04 Mflops = 468.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00217143; expected ratio = 0.0001obtained abs = 1.56323e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.413261; expected ratio = 0.001obtained abs = 137.921; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.612150e+05 Mflops = 337.92 -Solve time = 0.00 -Solve flops = 1.597600e+04 Mflops = 468.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000840635; expected ratio = 0.0001obtained abs = 6.05051e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.188333; expected ratio = 0.001obtained abs = 62.6589; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.612150e+05 Mflops = 337.25 -Solve time = 0.00 -Solve flops = 1.597600e+04 Mflops = 468.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000517264; expected ratio = 0.0001obtained abs = 3.72263e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.202515; expected ratio = 0.001obtained abs = 67.735; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 481.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000551284; expected ratio = 0.0001obtained abs = 3.96718e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.171219; expected ratio = 0.001obtained abs = 56.9345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 484.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000332666; expected ratio = 0.0001obtained abs = 2.39388e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146664; expected ratio = 0.001obtained abs = 48.968; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 481.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00029298; expected ratio = 0.0001obtained abs = 2.10827e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.098454; expected ratio = 0.001obtained abs = 32.7191; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 471.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000182437; expected ratio = 0.0001obtained abs = 1.31278e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.084414; expected ratio = 0.001obtained abs = 28.1585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 467.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000231392; expected ratio = 0.0001obtained abs = 1.66505e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0661138; expected ratio = 0.001obtained abs = 21.9922; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 481.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000143; expected ratio = 0.0001obtained abs = 1.02897e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0641992; expected ratio = 0.001obtained abs = 21.4154; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 471.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000164816; expected ratio = 0.0001obtained abs = 1.18593e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0597502; expected ratio = 0.001obtained abs = 19.8911; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 337.27 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 467.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000146672; expected ratio = 0.0001obtained abs = 1.05536e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0604067; expected ratio = 0.001obtained abs = 20.1491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 327.45 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 471.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000169277; expected ratio = 0.0001obtained abs = 1.21801e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0617641; expected ratio = 0.001obtained abs = 20.5703; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 481.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162745; expected ratio = 0.0001obtained abs = 1.171e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0632878; expected ratio = 0.001obtained abs = 21.1089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 467.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000181219; expected ratio = 0.0001obtained abs = 1.30393e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0668183; expected ratio = 0.001obtained abs = 22.2591; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 335.76 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 467.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000182624; expected ratio = 0.0001obtained abs = 1.31403e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0686981; expected ratio = 0.001obtained abs = 22.9124; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 337.10 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 471.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000198561; expected ratio = 0.0001obtained abs = 1.42871e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0734477; expected ratio = 0.001obtained abs = 24.4721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 467.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000205792; expected ratio = 0.0001obtained abs = 1.48073e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0754762; expected ratio = 0.001obtained abs = 25.1722; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.608230e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.594800e+04 Mflops = 467.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000221418; expected ratio = 0.0001obtained abs = 1.59318e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0814156; expected ratio = 0.001obtained abs = 27.1316; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08186 - Final Residual ratio : 0.000804518 - Residual ratio : 0.000743642 - Slope : -0.0372779 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07758 - Final Residual ratio : 0.000759823 - Residual ratio : 0.000705121 - Slope : -0.0371316 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06193 - Final Residual ratio : 0.000985575 - Residual ratio : 0.000928095 - Slope : -0.037891 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03826 - Final Residual ratio : 0.000633085 - Residual ratio : 0.000609755 - Slope : -0.0384307 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02932 - Final Residual ratio : 0.000839665 - Residual ratio : 0.000815745 - Slope : -0.039557 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00079 - Final Residual ratio : 0.00070063 - Residual ratio : 0.00070008 - Slope : -0.0333362 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3621 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.984934 - Final Residual ratio : 0.000571613 - Residual ratio : 0.000580357 - Slope : -0.0328121 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.972087 - Final Residual ratio : 0.000541329 - Residual ratio : 0.000556873 - Slope : -0.0323849 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.962191 - Final Residual ratio : 0.000670339 - Residual ratio : 0.00069668 - Slope : -0.0320507 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.973345 - Final Residual ratio : 0.00096104 - Residual ratio : 0.000987358 - Slope : -0.0373994 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 114 - Mesh triangles: 120 - Mesh edges: 195 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3651 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.617110e+05 Mflops = 339.64 -Solve time = 0.00 -Solve flops = 1.605400e+04 Mflops = 470.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0799584; expected ratio = 0.0001obtained abs = 0.000579296; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.281947; expected ratio = 0.001obtained abs = 98.7164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609550e+05 Mflops = 331.25 -Solve time = 0.00 -Solve flops = 1.602800e+04 Mflops = 470.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00941486; expected ratio = 0.0001obtained abs = 6.80761e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.563123; expected ratio = 0.001obtained abs = 187.047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00311717; expected ratio = 0.0001obtained abs = 2.25262e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.345489; expected ratio = 0.001obtained abs = 114.247; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 484.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117462; expected ratio = 0.0001obtained abs = 8.4866e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.148871; expected ratio = 0.001obtained abs = 48.9619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 335.67 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 474.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000411636; expected ratio = 0.0001obtained abs = 2.97395e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.152412; expected ratio = 0.001obtained abs = 50.4534; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000429869 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 341.42 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 471.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000341001; expected ratio = 0.0001obtained abs = 2.46353e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131703; expected ratio = 0.001obtained abs = 43.3429; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000429869 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 341.42 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 474.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00029235; expected ratio = 0.0001obtained abs = 2.11202e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.126174; expected ratio = 0.001obtained abs = 41.7538; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000429869 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000315397; expected ratio = 0.0001obtained abs = 2.27848e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.126127; expected ratio = 0.001obtained abs = 41.5646; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 471.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000315631; expected ratio = 0.0001obtained abs = 2.28015e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.128132; expected ratio = 0.001obtained abs = 42.3916; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 341.42 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 471.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000349225; expected ratio = 0.0001obtained abs = 2.52282e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138413; expected ratio = 0.001obtained abs = 45.6762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 484.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000364643; expected ratio = 0.0001obtained abs = 2.63418e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.143888; expected ratio = 0.001obtained abs = 47.6058; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 471.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000411063; expected ratio = 0.0001obtained abs = 2.96951e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134122; expected ratio = 0.001obtained abs = 44.2604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000302665; expected ratio = 0.0001obtained abs = 2.18645e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116966; expected ratio = 0.001obtained abs = 38.6312; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000430822 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 341.42 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000235336; expected ratio = 0.0001obtained abs = 1.70008e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.092434; expected ratio = 0.001obtained abs = 30.4895; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 340.05 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 471.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000203935; expected ratio = 0.0001obtained abs = 1.47322e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0910363; expected ratio = 0.001obtained abs = 30.0666; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 341.42 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000223464; expected ratio = 0.0001obtained abs = 1.61429e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0924527; expected ratio = 0.001obtained abs = 30.5069; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 341.42 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 474.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000238628; expected ratio = 0.0001obtained abs = 1.72382e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0961341; expected ratio = 0.001obtained abs = 31.7552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 341.42 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 474.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000264648; expected ratio = 0.0001obtained abs = 1.91179e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105151; expected ratio = 0.001obtained abs = 34.7111; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 341.42 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000284482; expected ratio = 0.0001obtained abs = 2.05506e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110601; expected ratio = 0.001obtained abs = 36.5437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614990e+05 Mflops = 340.73 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000311033; expected ratio = 0.0001obtained abs = 2.24687e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123058; expected ratio = 0.001obtained abs = 40.6444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3661 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.6607 - Final Residual ratio : 0.0135145 - Residual ratio : 0.000862957 - Slope : -0.558829 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.43629 - Final Residual ratio : 0.00411857 - Residual ratio : 0.000757606 - Slope : -0.181073 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3681 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.5117 - Final Residual ratio : 0.00220146 - Residual ratio : 0.000876481 - Slope : -0.0865346 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3691 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.62603 - Final Residual ratio : 0.00136393 - Residual ratio : 0.00083881 - Slope : -0.0580239 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47439 - Final Residual ratio : 0.00111205 - Residual ratio : 0.000754242 - Slope : -0.0526172 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33365 - Final Residual ratio : 0.00129104 - Residual ratio : 0.00096805 - Slope : -0.0512447 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19096 - Final Residual ratio : 0.00100483 - Residual ratio : 0.000843719 - Slope : -0.0457673 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07472 - Final Residual ratio : 0.00104928 - Residual ratio : 0.000976336 - Slope : -0.0397654 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00401 - Final Residual ratio : 0.000932704 - Residual ratio : 0.000928979 - Slope : -0.0590045 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.988669 - Final Residual ratio : 0.000946803 - Residual ratio : 0.000957654 - Slope : -0.0352758 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 120 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 114 - Mesh triangles: 119 - Mesh edges: 194 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3751 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.774590e+05 Mflops = 356.30 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 470.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0776443; expected ratio = 0.0001obtained abs = 0.000567005; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.249556; expected ratio = 0.001obtained abs = 86.8453; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.785690e+05 Mflops = 359.39 -Solve time = 0.00 -Solve flops = 1.694000e+04 Mflops = 483.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0103665; expected ratio = 0.0001obtained abs = 7.55342e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.433244; expected ratio = 0.001obtained abs = 144.175; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.783230e+05 Mflops = 358.90 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00195862; expected ratio = 0.0001obtained abs = 1.42712e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.251704; expected ratio = 0.001obtained abs = 84.0752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 357.55 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00120889; expected ratio = 0.0001obtained abs = 8.80801e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109533; expected ratio = 0.001obtained abs = 36.4053; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 358.24 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000580129; expected ratio = 0.0001obtained abs = 4.22675e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1042; expected ratio = 0.001obtained abs = 34.7796; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 356.70 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000272512; expected ratio = 0.0001obtained abs = 1.98547e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0817189; expected ratio = 0.001obtained abs = 27.171; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 357.55 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000183953; expected ratio = 0.0001obtained abs = 1.34025e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0771674; expected ratio = 0.001obtained abs = 25.7442; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 358.24 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00019257; expected ratio = 0.0001obtained abs = 1.40303e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0722853; expected ratio = 0.001obtained abs = 24.0493; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 351.80 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000189726; expected ratio = 0.0001obtained abs = 1.38231e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0726918; expected ratio = 0.001obtained abs = 24.2432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 358.24 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000200105; expected ratio = 0.0001obtained abs = 1.45793e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0737528; expected ratio = 0.001obtained abs = 24.5495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 357.55 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000204136; expected ratio = 0.0001obtained abs = 1.48729e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0748383; expected ratio = 0.001obtained abs = 24.9537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 358.24 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000214483; expected ratio = 0.0001obtained abs = 1.56268e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0781837; expected ratio = 0.001obtained abs = 26.0342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 348.51 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000221961; expected ratio = 0.0001obtained abs = 1.61715e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0796773; expected ratio = 0.001obtained abs = 26.5634; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 357.38 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000233728; expected ratio = 0.0001obtained abs = 1.70289e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0844246; expected ratio = 0.001obtained abs = 28.1211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 358.24 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00024353; expected ratio = 0.0001obtained abs = 1.77429e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0864238; expected ratio = 0.001obtained abs = 28.8104; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 358.24 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000256996; expected ratio = 0.0001obtained abs = 1.87241e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0922638; expected ratio = 0.001obtained abs = 30.7412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 357.38 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000268236; expected ratio = 0.0001obtained abs = 1.95429e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0953884; expected ratio = 0.001obtained abs = 31.7997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 357.38 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 514.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000281557; expected ratio = 0.0001obtained abs = 2.05136e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101712; expected ratio = 0.001obtained abs = 33.8992; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 358.24 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000293369; expected ratio = 0.0001obtained abs = 2.1374e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104809; expected ratio = 0.001obtained abs = 34.9427; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.773150e+05 Mflops = 357.55 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000306439; expected ratio = 0.0001obtained abs = 2.23264e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.111307; expected ratio = 0.001obtained abs = 37.108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.954207 - Final Residual ratio : 0.000630644 - Residual ratio : 0.000660909 - Slope : -0.0317859 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.923445 - Final Residual ratio : 0.000701994 - Residual ratio : 0.000760191 - Slope : -0.0307581 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.886752 - Final Residual ratio : 0.000748195 - Residual ratio : 0.000843747 - Slope : -0.0295335 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.851709 - Final Residual ratio : 0.000746992 - Residual ratio : 0.000877051 - Slope : -0.0315171 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.839571 - Final Residual ratio : 0.000627819 - Residual ratio : 0.000747785 - Slope : -0.0279648 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.814351 - Final Residual ratio : 0.000487417 - Residual ratio : 0.000598535 - Slope : -0.0271288 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.804194 - Final Residual ratio : 0.000437909 - Residual ratio : 0.000544532 - Slope : -0.0267919 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.799642 - Final Residual ratio : 0.000709859 - Residual ratio : 0.000887721 - Slope : -0.0275494 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.800466 - Final Residual ratio : 0.000638432 - Residual ratio : 0.000797576 - Slope : -0.0285653 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.816222 - Final Residual ratio : 0.000712167 - Residual ratio : 0.000872516 - Slope : -0.0313658 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 114 - Mesh triangles: 119 - Mesh edges: 194 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3851 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000475883 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.790400e+05 Mflops = 358.11 -Solve time = 0.00 -Solve flops = 1.702400e+04 Mflops = 485.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0753063; expected ratio = 0.0001obtained abs = 0.000557324; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.207383; expected ratio = 0.001obtained abs = 70.5929; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.814660e+05 Mflops = 364.35 -Solve time = 0.00 -Solve flops = 1.715200e+04 Mflops = 492.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00772488; expected ratio = 0.0001obtained abs = 5.70188e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.348814; expected ratio = 0.001obtained abs = 114.705; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.786140e+05 Mflops = 358.62 -Solve time = 0.00 -Solve flops = 1.700400e+04 Mflops = 488.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00247054; expected ratio = 0.0001obtained abs = 1.82307e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.208012; expected ratio = 0.001obtained abs = 69.0377; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.786140e+05 Mflops = 359.48 -Solve time = 0.00 -Solve flops = 1.700400e+04 Mflops = 485.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000841126; expected ratio = 0.0001obtained abs = 6.2061e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.118856; expected ratio = 0.001obtained abs = 39.3211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.17 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000414241; expected ratio = 0.0001obtained abs = 3.05618e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121788; expected ratio = 0.001obtained abs = 40.4552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 356.32 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000390998; expected ratio = 0.0001obtained abs = 2.88456e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.114541; expected ratio = 0.001obtained abs = 37.9578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.86 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000302593; expected ratio = 0.0001obtained abs = 2.23229e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11452; expected ratio = 0.001obtained abs = 38.0585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 348.63 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000337667; expected ratio = 0.0001obtained abs = 2.49099e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.118083; expected ratio = 0.001obtained abs = 39.1798; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.00 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000311613; expected ratio = 0.0001obtained abs = 2.29875e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121333; expected ratio = 0.001obtained abs = 40.333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.17 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000348497; expected ratio = 0.0001obtained abs = 2.57082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.12945; expected ratio = 0.001obtained abs = 42.9947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.86 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000343852; expected ratio = 0.0001obtained abs = 2.53652e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.133825; expected ratio = 0.001obtained abs = 44.496; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 356.49 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 443.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000406028; expected ratio = 0.0001obtained abs = 2.99518e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123342; expected ratio = 0.001obtained abs = 40.9604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.00 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000278415; expected ratio = 0.0001obtained abs = 2.0538e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10819; expected ratio = 0.001obtained abs = 35.9287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.69 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000191715; expected ratio = 0.0001obtained abs = 1.41424e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0834247; expected ratio = 0.001obtained abs = 27.6915; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.86 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 483.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000159796; expected ratio = 0.0001obtained abs = 1.17877e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0804308; expected ratio = 0.001obtained abs = 26.7104; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.00 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000176182; expected ratio = 0.0001obtained abs = 1.29965e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0768635; expected ratio = 0.001obtained abs = 25.5174; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.86 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000182033; expected ratio = 0.0001obtained abs = 1.3428e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0785252; expected ratio = 0.001obtained abs = 26.0814; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.69 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000196965; expected ratio = 0.0001obtained abs = 1.45295e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0812115; expected ratio = 0.001obtained abs = 26.9636; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.00 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 500.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000205352; expected ratio = 0.0001obtained abs = 1.51481e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.082636; expected ratio = 0.001obtained abs = 27.4488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771260e+05 Mflops = 357.86 -Solve time = 0.00 -Solve flops = 1.692800e+04 Mflops = 496.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000219769; expected ratio = 0.0001obtained abs = 1.62117e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0877245; expected ratio = 0.001obtained abs = 29.129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.81221 - Final Residual ratio : 0.000745885 - Residual ratio : 0.00091834 - Slope : -0.0312102 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.808573 - Final Residual ratio : 0.000599617 - Residual ratio : 0.000741575 - Slope : -0.0299249 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3881 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.797436 - Final Residual ratio : 0.000658702 - Residual ratio : 0.000826024 - Slope : -0.0274751 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.780775 - Final Residual ratio : 0.00069766 - Residual ratio : 0.000893547 - Slope : -0.0268992 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.772676 - Final Residual ratio : 0.000693318 - Residual ratio : 0.000897295 - Slope : -0.0275708 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.753156 - Final Residual ratio : 0.000744278 - Residual ratio : 0.000988211 - Slope : -0.0250804 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.743491 - Final Residual ratio : 0.000620818 - Residual ratio : 0.000835005 - Slope : -0.0247623 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.737899 - Final Residual ratio : 0.000605617 - Residual ratio : 0.000820731 - Slope : -0.0245765 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.735191 - Final Residual ratio : 0.000667972 - Residual ratio : 0.000908569 - Slope : -0.0244841 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.739582 - Final Residual ratio : 0.000684922 - Residual ratio : 0.000926092 - Slope : -0.0273666 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.3951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 114 - Mesh triangles: 119 - Mesh edges: 194 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.3951 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.689550e+05 Mflops = 338.58 -Solve time = 0.00 -Solve flops = 1.654800e+04 Mflops = 472.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0715058; expected ratio = 0.0001obtained abs = 0.000537766; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172536; expected ratio = 0.001obtained abs = 58.172; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.690330e+05 Mflops = 340.04 -Solve time = 0.00 -Solve flops = 1.655200e+04 Mflops = 485.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00741082; expected ratio = 0.0001obtained abs = 5.55364e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.291936; expected ratio = 0.001obtained abs = 96.6428; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.709470e+05 Mflops = 335.21 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00212027; expected ratio = 0.0001obtained abs = 1.58891e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19887; expected ratio = 0.001obtained abs = 66.3046; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.709470e+05 Mflops = 342.57 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 491.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000805662; expected ratio = 0.0001obtained abs = 6.03672e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.13295; expected ratio = 0.001obtained abs = 44.2689; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.709470e+05 Mflops = 343.39 -Solve time = 0.00 -Solve flops = 1.664800e+04 Mflops = 488.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000486517; expected ratio = 0.0001obtained abs = 3.64507e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122873; expected ratio = 0.001obtained abs = 40.9985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 345.55 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000391335; expected ratio = 0.0001obtained abs = 2.93182e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0826496; expected ratio = 0.001obtained abs = 27.5348; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 346.05 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 476.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000222574; expected ratio = 0.0001obtained abs = 1.66744e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0725229; expected ratio = 0.001obtained abs = 24.2084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 340.01 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000235311; expected ratio = 0.0001obtained abs = 1.76283e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0568445; expected ratio = 0.001obtained abs = 18.9568; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 345.38 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 493.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00013732; expected ratio = 0.0001obtained abs = 1.0287e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0552877; expected ratio = 0.001obtained abs = 18.4633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 346.05 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 503.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000153993; expected ratio = 0.0001obtained abs = 1.15359e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0498428; expected ratio = 0.001obtained abs = 16.6327; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 346.05 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 493.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000117424; expected ratio = 0.0001obtained abs = 8.79638e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0496823; expected ratio = 0.001obtained abs = 16.5947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 344.72 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 493.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00013537; expected ratio = 0.0001obtained abs = 1.01407e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0489171; expected ratio = 0.001obtained abs = 16.3285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 345.38 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000115997; expected ratio = 0.0001obtained abs = 8.68936e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0492766; expected ratio = 0.001obtained abs = 16.4609; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 346.21 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000130123; expected ratio = 0.0001obtained abs = 9.74755e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0499672; expected ratio = 0.001obtained abs = 16.6812; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 345.38 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 476.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000120963; expected ratio = 0.0001obtained abs = 9.06131e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.050567; expected ratio = 0.001obtained abs = 16.8928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 345.38 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00013097; expected ratio = 0.0001obtained abs = 9.81098e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0517858; expected ratio = 0.001obtained abs = 17.2892; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000459194 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 345.38 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 493.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000127665; expected ratio = 0.0001obtained abs = 9.5634e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0524867; expected ratio = 0.001obtained abs = 17.5344; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 337.31 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000134769; expected ratio = 0.0001obtained abs = 1.00956e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0539614; expected ratio = 0.001obtained abs = 18.0158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 344.72 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000134876; expected ratio = 0.0001obtained abs = 1.01035e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0547262; expected ratio = 0.001obtained abs = 18.2827; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.720210e+05 Mflops = 345.38 -Solve time = 0.00 -Solve flops = 1.670200e+04 Mflops = 489.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000140277; expected ratio = 0.0001obtained abs = 1.05082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0563976; expected ratio = 0.001obtained abs = 18.8293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.3961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.738973 - Final Residual ratio : 0.000501083 - Residual ratio : 0.00067808 - Slope : -0.0273508 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.739525 - Final Residual ratio : 0.000456012 - Residual ratio : 0.000616628 - Slope : -0.0273729 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.736748 - Final Residual ratio : 0.000734961 - Residual ratio : 0.000997575 - Slope : -0.0272597 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.3991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.729164 - Final Residual ratio : 0.000656928 - Residual ratio : 0.000900934 - Slope : -0.0251209 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.3991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.720525 - Final Residual ratio : 0.000590807 - Residual ratio : 0.000819967 - Slope : -0.0378913 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.708467 - Final Residual ratio : 0.000448862 - Residual ratio : 0.000633567 - Slope : -0.0272315 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.699088 - Final Residual ratio : 0.000650881 - Residual ratio : 0.000931043 - Slope : -0.0232812 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.692484 - Final Residual ratio : 0.000316968 - Residual ratio : 0.000457726 - Slope : -0.022328 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.687964 - Final Residual ratio : 0.000641848 - Residual ratio : 0.000932968 - Slope : -0.0229107 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.684223 - Final Residual ratio : 0.000515037 - Residual ratio : 0.000752733 - Slope : -0.0262965 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 119 - - Mesh vertices: 114 - Mesh triangles: 121 - Mesh edges: 197 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4051 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.457480e+05 Mflops = 306.88 -Solve time = 0.00 -Solve flops = 1.534400e+04 Mflops = 463.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0784788; expected ratio = 0.0001obtained abs = 0.000598042; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.379839; expected ratio = 0.001obtained abs = 135.024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.464380e+05 Mflops = 310.36 -Solve time = 0.00 -Solve flops = 1.537400e+04 Mflops = 450.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00911237; expected ratio = 0.0001obtained abs = 6.93249e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.292356; expected ratio = 0.001obtained abs = 101.071; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.464380e+05 Mflops = 310.83 -Solve time = 0.00 -Solve flops = 1.537400e+04 Mflops = 467.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00278305; expected ratio = 0.0001obtained abs = 2.11842e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.186385; expected ratio = 0.001obtained abs = 64.7686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.464380e+05 Mflops = 311.46 -Solve time = 0.00 -Solve flops = 1.537400e+04 Mflops = 467.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00158136; expected ratio = 0.0001obtained abs = 1.2036e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113398; expected ratio = 0.001obtained abs = 39.1871; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.464380e+05 Mflops = 310.36 -Solve time = 0.00 -Solve flops = 1.537400e+04 Mflops = 463.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00128918; expected ratio = 0.0001obtained abs = 9.81076e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108383; expected ratio = 0.001obtained abs = 37.6911; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.471580e+05 Mflops = 309.23 -Solve time = 0.00 -Solve flops = 1.540400e+04 Mflops = 464.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000915458; expected ratio = 0.0001obtained abs = 6.96582e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100658; expected ratio = 0.001obtained abs = 34.9381; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.471580e+05 Mflops = 309.23 -Solve time = 0.00 -Solve flops = 1.540400e+04 Mflops = 464.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000681904; expected ratio = 0.0001obtained abs = 5.18811e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100011; expected ratio = 0.001obtained abs = 34.8548; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.471580e+05 Mflops = 308.46 -Solve time = 0.00 -Solve flops = 1.540400e+04 Mflops = 468.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000610921; expected ratio = 0.0001obtained abs = 4.6476e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103085; expected ratio = 0.001obtained abs = 35.9084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.468220e+05 Mflops = 307.75 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 467.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000448372; expected ratio = 0.0001obtained abs = 3.41072e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105902; expected ratio = 0.001obtained abs = 36.9791; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000433207 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.468220e+05 Mflops = 308.37 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 467.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000478688; expected ratio = 0.0001obtained abs = 3.64114e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.111797; expected ratio = 0.001obtained abs = 39.0412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.468220e+05 Mflops = 308.53 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000373465; expected ratio = 0.0001obtained abs = 2.84063e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.115006; expected ratio = 0.001obtained abs = 40.2152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.00043416 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.468220e+05 Mflops = 303.96 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000394921; expected ratio = 0.0001obtained abs = 3.00374e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.101576; expected ratio = 0.001obtained abs = 35.5049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.468220e+05 Mflops = 307.91 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000263214; expected ratio = 0.0001obtained abs = 2.00195e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0920988; expected ratio = 0.001obtained abs = 32.2134; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.468220e+05 Mflops = 300.25 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 467.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000305632; expected ratio = 0.0001obtained abs = 2.32455e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0863134; expected ratio = 0.001obtained abs = 30.1918; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.468220e+05 Mflops = 307.91 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000261792; expected ratio = 0.0001obtained abs = 1.99107e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0869976; expected ratio = 0.001obtained abs = 30.4485; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.468220e+05 Mflops = 309.14 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000305786; expected ratio = 0.0001obtained abs = 2.32567e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0897521; expected ratio = 0.001obtained abs = 31.4121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.471580e+05 Mflops = 309.23 -Solve time = 0.00 -Solve flops = 1.540400e+04 Mflops = 468.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000275421; expected ratio = 0.0001obtained abs = 2.0947e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0915877; expected ratio = 0.001obtained abs = 32.0676; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000433207 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.471580e+05 Mflops = 309.08 -Solve time = 0.00 -Solve flops = 1.540400e+04 Mflops = 468.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000311145; expected ratio = 0.0001obtained abs = 2.36642e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0962422; expected ratio = 0.001obtained abs = 33.6959; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.471580e+05 Mflops = 309.23 -Solve time = 0.00 -Solve flops = 1.540400e+04 Mflops = 464.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000297636; expected ratio = 0.0001obtained abs = 2.26365e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0984345; expected ratio = 0.001obtained abs = 34.4736; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.471580e+05 Mflops = 309.08 -Solve time = 0.00 -Solve flops = 1.540400e+04 Mflops = 468.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000324815; expected ratio = 0.0001obtained abs = 2.47039e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103751; expected ratio = 0.001obtained abs = 36.3352; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.59767 - Final Residual ratio : 0.00209602 - Residual ratio : 0.000806886 - Slope : -0.0895026 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.03703 - Final Residual ratio : 0.0045889 - Residual ratio : 0.000911031 - Slope : -0.296026 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.67167 - Final Residual ratio : 0.00530608 - Residual ratio : 0.000935541 - Slope : -0.236099 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.35825 - Final Residual ratio : 0.00449502 - Residual ratio : 0.000838897 - Slope : -0.198287 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.63256 - Final Residual ratio : 0.00449602 - Residual ratio : 0.000970528 - Slope : -0.178002 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.8781 - Final Residual ratio : 0.00341038 - Residual ratio : 0.000879395 - Slope : -0.154987 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.31459 - Final Residual ratio : 0.00287312 - Residual ratio : 0.000866811 - Slope : -0.194807 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.98656 - Final Residual ratio : 0.00230792 - Residual ratio : 0.000772769 - Slope : -0.110528 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.79324 - Final Residual ratio : 0.00217971 - Residual ratio : 0.000780353 - Slope : -0.0996807 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.62733 - Final Residual ratio : 0.00240846 - Residual ratio : 0.000916696 - Slope : -0.0937471 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 120 - - Mesh vertices: 114 - Mesh triangles: 120 - Mesh edges: 196 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4151 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.445320e+05 Mflops = 305.55 -Solve time = 0.00 -Solve flops = 1.523600e+04 Mflops = 450.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0753307; expected ratio = 0.0001obtained abs = 0.000584783; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166053; expected ratio = 0.001obtained abs = 55.1767; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.466260e+05 Mflops = 311.23 -Solve time = 0.00 -Solve flops = 1.533600e+04 Mflops = 466.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00759031; expected ratio = 0.0001obtained abs = 5.87851e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.205963; expected ratio = 0.001obtained abs = 67.6103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.451440e+05 Mflops = 311.40 -Solve time = 0.00 -Solve flops = 1.526600e+04 Mflops = 463.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0027211; expected ratio = 0.0001obtained abs = 2.10727e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155082; expected ratio = 0.001obtained abs = 51.2087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 313.55 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00189389; expected ratio = 0.0001obtained abs = 1.46697e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.12306; expected ratio = 0.001obtained abs = 40.4818; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.451440e+05 Mflops = 310.92 -Solve time = 0.00 -Solve flops = 1.526600e+04 Mflops = 460.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00159496; expected ratio = 0.0001obtained abs = 1.23522e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.124823; expected ratio = 0.001obtained abs = 41.1538; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.10 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00130778; expected ratio = 0.0001obtained abs = 1.01296e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10559; expected ratio = 0.001obtained abs = 34.7245; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.90 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 461.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00103575; expected ratio = 0.0001obtained abs = 8.02172e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.09081; expected ratio = 0.001obtained abs = 29.8943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.10 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000844679; expected ratio = 0.0001obtained abs = 6.54256e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0693561; expected ratio = 0.001obtained abs = 22.804; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 307.70 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 448.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000644621; expected ratio = 0.0001obtained abs = 4.99262e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0692825; expected ratio = 0.001obtained abs = 22.8091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.26 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000505137; expected ratio = 0.0001obtained abs = 3.91252e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0656334; expected ratio = 0.001obtained abs = 21.5847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.10 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000385674; expected ratio = 0.0001obtained abs = 2.9871e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0653682; expected ratio = 0.001obtained abs = 21.5197; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000429869 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.10 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000306891; expected ratio = 0.0001obtained abs = 2.377e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0641635; expected ratio = 0.001obtained abs = 21.1035; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.90 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000238184; expected ratio = 0.0001obtained abs = 1.84479e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.063924; expected ratio = 0.001obtained abs = 21.0438; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.90 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 461.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000201137; expected ratio = 0.0001obtained abs = 1.55787e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0634974; expected ratio = 0.001obtained abs = 20.8855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.90 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000171489; expected ratio = 0.0001obtained abs = 1.32823e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0632997; expected ratio = 0.001obtained abs = 20.8378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000429869 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.10 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162943; expected ratio = 0.0001obtained abs = 1.26205e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0630857; expected ratio = 0.001obtained abs = 20.7506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 308.16 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000157712; expected ratio = 0.0001obtained abs = 1.22153e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0629141; expected ratio = 0.001obtained abs = 20.7105; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 303.71 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000160881; expected ratio = 0.0001obtained abs = 1.24607e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0627399; expected ratio = 0.001obtained abs = 20.6369; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.90 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000163983; expected ratio = 0.0001obtained abs = 1.2701e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0625799; expected ratio = 0.001obtained abs = 20.6; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.454740e+05 Mflops = 312.74 -Solve time = 0.00 -Solve flops = 1.528800e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000168651; expected ratio = 0.0001obtained abs = 1.30625e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0623959; expected ratio = 0.001obtained abs = 20.5237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.45283 - Final Residual ratio : 0.00223702 - Residual ratio : 0.000912018 - Slope : -0.084503 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.29631 - Final Residual ratio : 0.00210257 - Residual ratio : 0.00091563 - Slope : -0.0791105 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 225.999 - Final Residual ratio : 0.197428 - Residual ratio : 0.000873581 - Slope : -9.40839 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 111.08 - Final Residual ratio : 0.108765 - Residual ratio : 0.00097916 - Slope : -10.0883 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.2214 - Final Residual ratio : 0.0624344 - Residual ratio : 0.000876625 - Slope : -2.63552 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.0986 - Final Residual ratio : 0.0185939 - Residual ratio : 0.000881283 - Slope : -0.810771 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.2924 - Final Residual ratio : 0.0101953 - Residual ratio : 0.000767007 - Slope : -0.491932 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9244 - Final Residual ratio : 0.00803396 - Residual ratio : 0.000673743 - Slope : -0.425583 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.8253 - Final Residual ratio : 0.0105373 - Residual ratio : 0.00097339 - Slope : -0.386243 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.4251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.8196 - Final Residual ratio : 0.00629856 - Residual ratio : 0.000641428 - Slope : -0.33839 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 120 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 119 - - Mesh vertices: 114 - Mesh triangles: 119 - Mesh edges: 195 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4251 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.444620e+05 Mflops = 308.04 -Solve time = 0.00 -Solve flops = 1.523200e+04 Mflops = 446.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0699666; expected ratio = 0.0001obtained abs = 0.000555908; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0988952; expected ratio = 0.001obtained abs = 32.3002; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.444620e+05 Mflops = 311.37 -Solve time = 0.00 -Solve flops = 1.523200e+04 Mflops = 345.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00776472; expected ratio = 0.0001obtained abs = 6.14947e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.118544; expected ratio = 0.001obtained abs = 38.7792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.445740e+05 Mflops = 311.45 -Solve time = 0.00 -Solve flops = 1.524000e+04 Mflops = 463.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00305494; expected ratio = 0.0001obtained abs = 2.41961e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0810883; expected ratio = 0.001obtained abs = 26.7688; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.445740e+05 Mflops = 312.89 -Solve time = 0.00 -Solve flops = 1.524000e+04 Mflops = 450.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00089155; expected ratio = 0.0001obtained abs = 7.06021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0673938; expected ratio = 0.001obtained abs = 22.265; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 462.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000552671; expected ratio = 0.0001obtained abs = 4.37626e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0698452; expected ratio = 0.001obtained abs = 23.1487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000418234; expected ratio = 0.0001obtained abs = 3.31157e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.068083; expected ratio = 0.001obtained abs = 22.5625; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 449.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00029174; expected ratio = 0.0001obtained abs = 2.30991e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0682525; expected ratio = 0.001obtained abs = 22.6599; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 462.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000259602; expected ratio = 0.0001obtained abs = 2.05541e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0670408; expected ratio = 0.001obtained abs = 22.2465; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 462.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000201447; expected ratio = 0.0001obtained abs = 1.59493e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0669856; expected ratio = 0.001obtained abs = 22.2565; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.18 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 446.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000203345; expected ratio = 0.0001obtained abs = 1.60995e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0659722; expected ratio = 0.001obtained abs = 21.9054; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.18 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 462.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000173512; expected ratio = 0.0001obtained abs = 1.37373e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0657807; expected ratio = 0.001obtained abs = 21.8638; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000179874; expected ratio = 0.0001obtained abs = 1.4241e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0647595; expected ratio = 0.001obtained abs = 21.5092; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 462.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162486; expected ratio = 0.0001obtained abs = 1.28643e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0644674; expected ratio = 0.001obtained abs = 21.4304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 311.46 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 446.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000166748; expected ratio = 0.0001obtained abs = 1.32017e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.063369; expected ratio = 0.001obtained abs = 21.0503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000155953; expected ratio = 0.0001obtained abs = 1.2347e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0629841; expected ratio = 0.001obtained abs = 20.9385; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 311.46 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00015765; expected ratio = 0.0001obtained abs = 1.24814e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0617845; expected ratio = 0.001obtained abs = 20.5252; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 306.25 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000150506; expected ratio = 0.0001obtained abs = 1.19158e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0613126; expected ratio = 0.001obtained abs = 20.3831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 462.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000150258; expected ratio = 0.0001obtained abs = 1.18961e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0600109; expected ratio = 0.001obtained abs = 19.9365; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000145102; expected ratio = 0.0001obtained abs = 1.14879e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0594586; expected ratio = 0.001obtained abs = 19.7665; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000143561; expected ratio = 0.0001obtained abs = 1.13659e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0580647; expected ratio = 0.001obtained abs = 19.29; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.44704 - Final Residual ratio : 0.00836888 - Residual ratio : 0.000990747 - Slope : -0.324564 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.5188 - Final Residual ratio : 0.0055367 - Residual ratio : 0.000736381 - Slope : -0.268331 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.89111 - Final Residual ratio : 0.00516496 - Residual ratio : 0.000749511 - Slope : -0.255035 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.44546 - Final Residual ratio : 0.00508216 - Residual ratio : 0.000788488 - Slope : -0.257615 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.7935 - Final Residual ratio : 0.00559759 - Residual ratio : 0.000966184 - Slope : -0.214367 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.89509 - Final Residual ratio : 0.00582948 - Residual ratio : 0.00098887 - Slope : -0.218121 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.87247 - Final Residual ratio : 0.00483344 - Residual ratio : 0.000823067 - Slope : -0.21732 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.68615 - Final Residual ratio : 0.00468685 - Residual ratio : 0.000824257 - Slope : -0.202909 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4341 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 120.191 - Final Residual ratio : 0.114398 - Residual ratio : 0.000951806 - Slope : -5.00318 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 59.7715 - Final Residual ratio : 0.0517232 - Residual ratio : 0.00086535 - Slope : -4.97664 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 119 - - Mesh vertices: 114 - Mesh triangles: 119 - Mesh edges: 195 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4351 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.445740e+05 Mflops = 310.33 -Solve time = 0.00 -Solve flops = 1.524000e+04 Mflops = 447.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0685026; expected ratio = 0.0001obtained abs = 0.00055734; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0917085; expected ratio = 0.001obtained abs = 30.0582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.445740e+05 Mflops = 311.61 -Solve time = 0.00 -Solve flops = 1.524000e+04 Mflops = 463.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00599925; expected ratio = 0.0001obtained abs = 4.86523e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0898313; expected ratio = 0.001obtained abs = 29.4946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.445740e+05 Mflops = 311.61 -Solve time = 0.00 -Solve flops = 1.524000e+04 Mflops = 459.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00142697; expected ratio = 0.0001obtained abs = 1.15741e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.066505; expected ratio = 0.001obtained abs = 21.9816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.18 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 462.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000673582; expected ratio = 0.0001obtained abs = 5.46276e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0560205; expected ratio = 0.001obtained abs = 18.5232; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 446.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000444245; expected ratio = 0.0001obtained abs = 3.60261e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0568067; expected ratio = 0.001obtained abs = 18.8363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.18 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000342458; expected ratio = 0.0001obtained abs = 2.77706e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0534106; expected ratio = 0.001obtained abs = 17.7077; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 309.55 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00024233; expected ratio = 0.0001obtained abs = 1.96504e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0524813; expected ratio = 0.001obtained abs = 17.4302; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 309.55 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0002116; expected ratio = 0.0001obtained abs = 1.71582e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0496517; expected ratio = 0.001obtained abs = 16.4829; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.18 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0001589; expected ratio = 0.0001obtained abs = 1.28846e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.048529; expected ratio = 0.001obtained abs = 16.1303; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000153983; expected ratio = 0.0001obtained abs = 1.24858e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0459813; expected ratio = 0.001obtained abs = 15.2744; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 462.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000121878; expected ratio = 0.0001obtained abs = 9.8825e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0447608; expected ratio = 0.001obtained abs = 14.8832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.18 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 458.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000122919; expected ratio = 0.0001obtained abs = 9.96686e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0423804; expected ratio = 0.001obtained abs = 14.0828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.82 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 449.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000101898; expected ratio = 0.0001obtained abs = 8.26233e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0411145; expected ratio = 0.001obtained abs = 13.6728; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 303.02 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 449.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000102911; expected ratio = 0.0001obtained abs = 8.34445e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0388774; expected ratio = 0.001obtained abs = 12.9208; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.439140e+05 Mflops = 310.18 -Solve time = 0.00 -Solve flops = 1.521000e+04 Mflops = 462.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.88659e-05; expected ratio = 0.0001obtained abs = 7.20561e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0375987; expected ratio = 0.001obtained abs = 12.5042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.0758 - Final Residual ratio : 0.0191996 - Residual ratio : 0.000709107 - Slope : -1.04064 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.854 - Final Residual ratio : 0.015766 - Residual ratio : 0.000935445 - Slope : -0.673529 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.6509 - Final Residual ratio : 0.0142278 - Residual ratio : 0.000971121 - Slope : -0.542099 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.6846 - Final Residual ratio : 0.0135797 - Residual ratio : 0.00099233 - Slope : -0.594393 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.5886 - Final Residual ratio : 0.0120258 - Residual ratio : 0.000955287 - Slope : -0.546809 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.4215 - Final Residual ratio : 0.0111979 - Residual ratio : 0.000980421 - Slope : -0.438859 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4421 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3125 - Final Residual ratio : 0.00719063 - Residual ratio : 0.000697275 - Slope : -0.396357 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.35245 - Final Residual ratio : 0.00777927 - Residual ratio : 0.000831789 - Slope : -0.333738 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.52315 - Final Residual ratio : 0.00839842 - Residual ratio : 0.000985365 - Slope : -0.304098 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.83351 - Final Residual ratio : 0.00662657 - Residual ratio : 0.000845925 - Slope : -0.279532 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 15 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 119 - - Mesh vertices: 114 - Mesh triangles: 119 - Mesh edges: 195 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4451 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 309.76 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 450.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0654667; expected ratio = 0.0001obtained abs = 0.000546075; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.064991; expected ratio = 0.001obtained abs = 21.4143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.458630e+05 Mflops = 315.68 -Solve time = 0.00 -Solve flops = 1.532000e+04 Mflops = 465.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00641301; expected ratio = 0.0001obtained abs = 5.33295e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0591433; expected ratio = 0.001obtained abs = 19.6725; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 316.46 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 466.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00244626; expected ratio = 0.0001obtained abs = 2.03441e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.036352; expected ratio = 0.001obtained abs = 12.1747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 317.11 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 450.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00104476; expected ratio = 0.0001obtained abs = 8.68741e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0254096; expected ratio = 0.001obtained abs = 8.53567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 317.28 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 450.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000710082; expected ratio = 0.0001obtained abs = 5.90399e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0233621; expected ratio = 0.001obtained abs = 7.86685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 324.14 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 480.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000509755; expected ratio = 0.0001obtained abs = 4.2381e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0208319; expected ratio = 0.001obtained abs = 7.02678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 316.46 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 450.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00037115; expected ratio = 0.0001obtained abs = 3.08561e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0196623; expected ratio = 0.001obtained abs = 6.63947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 316.46 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 466.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000274618; expected ratio = 0.0001obtained abs = 2.28301e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0181201; expected ratio = 0.001obtained abs = 6.12411; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 316.46 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 450.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000215503; expected ratio = 0.0001obtained abs = 1.79153e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170865; expected ratio = 0.001obtained abs = 5.77749; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 316.46 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 466.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000164442; expected ratio = 0.0001obtained abs = 1.36703e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0158688; expected ratio = 0.001obtained abs = 5.36835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 316.46 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 463.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000134981; expected ratio = 0.0001obtained abs = 1.1221e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0148998; expected ratio = 0.001obtained abs = 5.04133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 315.65 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 453.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000103664; expected ratio = 0.0001obtained abs = 8.61755e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0138842; expected ratio = 0.001obtained abs = 4.69907; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.465230e+05 Mflops = 316.46 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 466.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.75702e-05; expected ratio = 0.0001obtained abs = 7.27968e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0129978; expected ratio = 0.001obtained abs = 4.39908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.22692 - Final Residual ratio : 0.0064058 - Residual ratio : 0.00088638 - Slope : -0.40114 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.78211 - Final Residual ratio : 0.00670725 - Residual ratio : 0.000988962 - Slope : -0.294583 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.42419 - Final Residual ratio : 0.00534952 - Residual ratio : 0.000832714 - Slope : -0.256754 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.09298 - Final Residual ratio : 0.00407971 - Residual ratio : 0.000669576 - Slope : -0.434921 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.83482 - Final Residual ratio : 0.00504832 - Residual ratio : 0.000865205 - Slope : -0.208206 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.40606 - Final Residual ratio : 0.00491684 - Residual ratio : 0.000909507 - Slope : -0.192898 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.0584 - Final Residual ratio : 0.00411417 - Residual ratio : 0.000813334 - Slope : -0.18051 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.7498 - Final Residual ratio : 0.00320051 - Residual ratio : 0.000673819 - Slope : -0.182562 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48566 - Final Residual ratio : 0.00326273 - Residual ratio : 0.000727369 - Slope : -0.160086 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.38304 - Final Residual ratio : 0.00367275 - Residual ratio : 0.000837947 - Slope : -0.156406 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 13 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 119 - - Mesh vertices: 114 - Mesh triangles: 119 - Mesh edges: 195 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4551 -matrix_partition : [5](0,48,96,144,195) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.468730e+05 Mflops = 315.27 -Solve time = 0.00 -Solve flops = 1.537000e+04 Mflops = 450.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0632777; expected ratio = 0.0001obtained abs = 0.000541332; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0766186; expected ratio = 0.001obtained abs = 24.8507; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.462850e+05 Mflops = 315.29 -Solve time = 0.00 -Solve flops = 1.535000e+04 Mflops = 466.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00578366; expected ratio = 0.0001obtained abs = 4.93316e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0409489; expected ratio = 0.001obtained abs = 13.3988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 318.19 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00169398; expected ratio = 0.0001obtained abs = 1.44509e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0206928; expected ratio = 0.001obtained abs = 6.81235; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 317.37 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000973657; expected ratio = 0.0001obtained abs = 8.30483e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.015156; expected ratio = 0.001obtained abs = 5.00444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 313.34 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000632718; expected ratio = 0.0001obtained abs = 5.39644e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136993; expected ratio = 0.001obtained abs = 4.53494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 317.37 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 454.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000476902; expected ratio = 0.0001obtained abs = 4.06728e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0121446; expected ratio = 0.001obtained abs = 4.0259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 317.53 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 451.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000343377; expected ratio = 0.0001obtained abs = 2.9284e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0111958; expected ratio = 0.001obtained abs = 3.71688; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 317.37 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00027294; expected ratio = 0.0001obtained abs = 2.32764e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103171; expected ratio = 0.001obtained abs = 3.42727; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 317.37 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 467.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000204739; expected ratio = 0.0001obtained abs = 1.74599e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00961747; expected ratio = 0.001obtained abs = 3.19771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 317.37 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 451.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000168012; expected ratio = 0.0001obtained abs = 1.43276e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0090102; expected ratio = 0.001obtained abs = 2.99646; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 318.19 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000128022; expected ratio = 0.0001obtained abs = 1.09173e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00846676; expected ratio = 0.001obtained abs = 2.81728; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 318.19 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 464.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000107374; expected ratio = 0.0001obtained abs = 9.1564e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00799683; expected ratio = 0.001obtained abs = 2.66099; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 195 -RHS size in solver: 195 -Factor time = 0.00 -Factor flops = 1.469450e+05 Mflops = 312.70 -Solve time = 0.00 -Solve flops = 1.538000e+04 Mflops = 467.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.18492e-05; expected ratio = 0.0001obtained abs = 6.97973e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00755034; expected ratio = 0.001obtained abs = 2.5133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.11895 - Final Residual ratio : 0.00394074 - Residual ratio : 0.000956735 - Slope : -0.1646 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.959 - Final Residual ratio : 0.00379931 - Residual ratio : 0.000959665 - Slope : -0.1648 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.81323 - Final Residual ratio : 0.00358242 - Residual ratio : 0.000939471 - Slope : -0.190482 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.65617 - Final Residual ratio : 0.00353864 - Residual ratio : 0.000967856 - Slope : -0.135282 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.63203 - Final Residual ratio : 0.0018751 - Residual ratio : 0.000516268 - Slope : -0.125178 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.37114 - Final Residual ratio : 0.00180648 - Residual ratio : 0.000535865 - Slope : -0.116184 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8716 - Final Residual ratio : 0.0111786 - Residual ratio : 0.000868466 - Slope : -0.514417 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.9295 - Final Residual ratio : 0.025455 - Residual ratio : 0.000911402 - Slope : -1.03348 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.974 - Final Residual ratio : 0.0267922 - Residual ratio : 0.000812526 - Slope : -1.2672 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.55883 - Final Residual ratio : 0.00421743 - Residual ratio : 0.000643015 - Slope : -0.234093 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 13 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4651 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.441660e+05 Mflops = 321.12 -Solve time = 0.00 -Solve flops = 1.512200e+04 Mflops = 443.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0618013; expected ratio = 0.0001obtained abs = 0.000546546; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0837135; expected ratio = 0.001obtained abs = 28.0279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.438300e+05 Mflops = 321.06 -Solve time = 0.00 -Solve flops = 1.509800e+04 Mflops = 472.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00564638; expected ratio = 0.0001obtained abs = 4.97908e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0396929; expected ratio = 0.001obtained abs = 13.5171; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.440100e+05 Mflops = 321.46 -Solve time = 0.00 -Solve flops = 1.511000e+04 Mflops = 459.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00385713; expected ratio = 0.0001obtained abs = 3.40116e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0196673; expected ratio = 0.001obtained abs = 6.73811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 318.30 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 470.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00190495; expected ratio = 0.0001obtained abs = 1.67941e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122941; expected ratio = 0.001obtained abs = 4.23441; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 318.30 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 453.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0013215; expected ratio = 0.0001obtained abs = 1.1649e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0111413; expected ratio = 0.001obtained abs = 3.85053; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 317.62 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 466.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000894344; expected ratio = 0.0001obtained abs = 7.88293e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00883048; expected ratio = 0.001obtained abs = 3.06027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 317.62 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 470.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000648917; expected ratio = 0.0001obtained abs = 5.71931e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0083988; expected ratio = 0.001obtained abs = 2.91663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 317.62 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 456.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000477457; expected ratio = 0.0001obtained abs = 4.20793e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00696711; expected ratio = 0.001obtained abs = 2.42299; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 318.47 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 453.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000357378; expected ratio = 0.0001obtained abs = 3.14954e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00662146; expected ratio = 0.001obtained abs = 2.30534; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 316.78 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 470.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000273141; expected ratio = 0.0001obtained abs = 2.40711e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00561263; expected ratio = 0.001obtained abs = 1.95556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 317.62 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 453.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000216267; expected ratio = 0.0001obtained abs = 1.90588e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00535795; expected ratio = 0.001obtained abs = 1.86782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 318.30 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 456.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000175039; expected ratio = 0.0001obtained abs = 1.54253e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00467393; expected ratio = 0.001obtained abs = 1.62996; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 318.47 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 453.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000146632; expected ratio = 0.0001obtained abs = 1.29219e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00448084; expected ratio = 0.001obtained abs = 1.56295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 317.62 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 456.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000122689; expected ratio = 0.0001obtained abs = 1.08119e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00401251; expected ratio = 0.001obtained abs = 1.39982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.0004282 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 309.37 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 456.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000105138; expected ratio = 0.0001obtained abs = 9.26521e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00384747; expected ratio = 0.001obtained abs = 1.3423; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000425816 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.419880e+05 Mflops = 317.62 -Solve time = 0.00 -Solve flops = 1.502000e+04 Mflops = 456.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.80079e-05; expected ratio = 0.0001obtained abs = 7.75563e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00351355; expected ratio = 0.001obtained abs = 1.22588; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.48564 - Final Residual ratio : 0.0055015 - Residual ratio : 0.00073494 - Slope : -0.267148 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.40556 - Final Residual ratio : 0.00615323 - Residual ratio : 0.000732044 - Slope : -0.299979 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2962 - Final Residual ratio : 0.0136745 - Residual ratio : 0.000839121 - Slope : -0.58152 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 92.3737 - Final Residual ratio : 0.0795905 - Residual ratio : 0.000861614 - Slope : -3.4183 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 91.9999 - Final Residual ratio : 0.080368 - Residual ratio : 0.000873566 - Slope : -3.28284 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.8232 - Final Residual ratio : 0.0268481 - Residual ratio : 0.000900243 - Slope : -1.14601 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.7558 - Final Residual ratio : 0.0177553 - Residual ratio : 0.000596699 - Slope : -1.06207 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.215 - Final Residual ratio : 0.0317973 - Residual ratio : 0.000987033 - Slope : -1.1494 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 57.4065 - Final Residual ratio : 0.0371998 - Residual ratio : 0.000648008 - Slope : -1.97825 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 77.0144 - Final Residual ratio : 0.0663377 - Residual ratio : 0.000861367 - Slope : -3.20617 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 16 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4751 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000430822 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.370090e+05 Mflops = 317.84 -Solve time = 0.00 -Solve flops = 1.483200e+04 Mflops = 450.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0632721; expected ratio = 0.0001obtained abs = 0.00057331; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.129274; expected ratio = 0.001obtained abs = 41.7182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.386110e+05 Mflops = 320.14 -Solve time = 0.00 -Solve flops = 1.491600e+04 Mflops = 466.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0104984; expected ratio = 0.0001obtained abs = 9.49544e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0507897; expected ratio = 0.001obtained abs = 16.6514; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.390030e+05 Mflops = 315.15 -Solve time = 0.00 -Solve flops = 1.494400e+04 Mflops = 467.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00163508; expected ratio = 0.0001obtained abs = 1.47909e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234423; expected ratio = 0.001obtained abs = 7.72035; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.390030e+05 Mflops = 321.05 -Solve time = 0.00 -Solve flops = 1.494400e+04 Mflops = 454.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108255; expected ratio = 0.0001obtained abs = 9.79173e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0128375; expected ratio = 0.001obtained abs = 4.24839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.390030e+05 Mflops = 321.05 -Solve time = 0.00 -Solve flops = 1.494400e+04 Mflops = 450.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000867455; expected ratio = 0.0001obtained abs = 7.84565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0107115; expected ratio = 0.001obtained abs = 3.55518; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.383730e+05 Mflops = 322.43 -Solve time = 0.00 -Solve flops = 1.491400e+04 Mflops = 466.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00066352; expected ratio = 0.0001obtained abs = 6.00086e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00831083; expected ratio = 0.001obtained abs = 2.76534; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.380370e+05 Mflops = 322.55 -Solve time = 0.00 -Solve flops = 1.489000e+04 Mflops = 449.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000507953; expected ratio = 0.0001obtained abs = 4.59373e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00752678; expected ratio = 0.001obtained abs = 2.50917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.380370e+05 Mflops = 313.80 -Solve time = 0.00 -Solve flops = 1.489000e+04 Mflops = 449.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000388129; expected ratio = 0.0001obtained abs = 3.50998e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00588883; expected ratio = 0.001obtained abs = 1.96584; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.380370e+05 Mflops = 322.55 -Solve time = 0.00 -Solve flops = 1.489000e+04 Mflops = 466.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000297307; expected ratio = 0.0001obtained abs = 2.68859e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00535117; expected ratio = 0.001obtained abs = 1.78834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.380370e+05 Mflops = 321.65 -Solve time = 0.00 -Solve flops = 1.489000e+04 Mflops = 452.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00022888; expected ratio = 0.0001obtained abs = 2.06975e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00416308; expected ratio = 0.001obtained abs = 1.39229; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.380370e+05 Mflops = 316.72 -Solve time = 0.00 -Solve flops = 1.489000e+04 Mflops = 449.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000176503; expected ratio = 0.0001obtained abs = 1.5961e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00377531; expected ratio = 0.001obtained abs = 1.26335; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.380370e+05 Mflops = 321.65 -Solve time = 0.00 -Solve flops = 1.489000e+04 Mflops = 466.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000138094; expected ratio = 0.0001obtained abs = 1.24876e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00295321; expected ratio = 0.001obtained abs = 0.988597; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.380370e+05 Mflops = 322.37 -Solve time = 0.00 -Solve flops = 1.489000e+04 Mflops = 452.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000109077; expected ratio = 0.0001obtained abs = 9.8635e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00268511; expected ratio = 0.001obtained abs = 0.899097; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.380370e+05 Mflops = 321.65 -Solve time = 0.00 -Solve flops = 1.489000e+04 Mflops = 466.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.75002e-05; expected ratio = 0.0001obtained abs = 7.91238e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00213634; expected ratio = 0.001obtained abs = 0.715451; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4761 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.1794 - Final Residual ratio : 0.0328195 - Residual ratio : 0.000710696 - Slope : -1.64809 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.8002 - Final Residual ratio : 0.0162533 - Residual ratio : 0.000745555 - Slope : -0.837845 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.1228 - Final Residual ratio : 0.0107454 - Residual ratio : 0.000818831 - Slope : -0.771299 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.438 - Final Residual ratio : 0.0110681 - Residual ratio : 0.000889866 - Slope : -0.477958 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.5074 - Final Residual ratio : 0.0150707 - Residual ratio : 0.000814302 - Slope : -0.637668 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.70236 - Final Residual ratio : 0.00846376 - Residual ratio : 0.00087234 - Slope : -0.346211 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.9018 - Final Residual ratio : 0.0302441 - Residual ratio : 0.000978718 - Slope : -1.10256 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4831 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 58.3607 - Final Residual ratio : 0.0441233 - Residual ratio : 0.000756046 - Slope : -2.33266 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.4726 - Final Residual ratio : 0.0318283 - Residual ratio : 0.000656625 - Slope : -1.86311 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.8959 - Final Residual ratio : 0.00853454 - Residual ratio : 0.000783282 - Slope : -0.403235 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 14 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4851 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.375790e+05 Mflops = 317.76 -Solve time = 0.00 -Solve flops = 1.484200e+04 Mflops = 438.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0556499; expected ratio = 0.0001obtained abs = 0.000517751; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.124197; expected ratio = 0.001obtained abs = 40.0095; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.378790e+05 Mflops = 316.88 -Solve time = 0.00 -Solve flops = 1.486400e+04 Mflops = 451.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00601458; expected ratio = 0.0001obtained abs = 5.58119e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0444781; expected ratio = 0.001obtained abs = 14.5294; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.375490e+05 Mflops = 307.04 -Solve time = 0.00 -Solve flops = 1.484200e+04 Mflops = 451.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00245495; expected ratio = 0.0001obtained abs = 2.27821e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.024528; expected ratio = 0.001obtained abs = 8.0571; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.375490e+05 Mflops = 315.43 -Solve time = 0.00 -Solve flops = 1.484200e+04 Mflops = 451.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00159085; expected ratio = 0.0001obtained abs = 1.47615e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0180905; expected ratio = 0.001obtained abs = 5.97564; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.375490e+05 Mflops = 315.43 -Solve time = 0.00 -Solve flops = 1.484200e+04 Mflops = 464.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116779; expected ratio = 0.0001obtained abs = 1.08352e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0138179; expected ratio = 0.001obtained abs = 4.57929; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.375490e+05 Mflops = 315.43 -Solve time = 0.00 -Solve flops = 1.484200e+04 Mflops = 464.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000970673; expected ratio = 0.0001obtained abs = 9.00582e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115623; expected ratio = 0.001obtained abs = 3.84546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.365830e+05 Mflops = 317.56 -Solve time = 0.00 -Solve flops = 1.478800e+04 Mflops = 462.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000806524; expected ratio = 0.0001obtained abs = 7.48247e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0104201; expected ratio = 0.001obtained abs = 3.47436; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.361630e+05 Mflops = 317.28 -Solve time = 0.00 -Solve flops = 1.475800e+04 Mflops = 461.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000678244; expected ratio = 0.0001obtained abs = 6.29209e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00898084; expected ratio = 0.001obtained abs = 3.00209; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.361630e+05 Mflops = 317.99 -Solve time = 0.00 -Solve flops = 1.475800e+04 Mflops = 461.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000576453; expected ratio = 0.0001obtained abs = 5.34758e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00840301; expected ratio = 0.001obtained abs = 2.81466; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363430e+05 Mflops = 318.59 -Solve time = 0.00 -Solve flops = 1.477000e+04 Mflops = 458.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000504421; expected ratio = 0.0001obtained abs = 4.67921e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00730214; expected ratio = 0.001obtained abs = 2.45072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363430e+05 Mflops = 308.62 -Solve time = 0.00 -Solve flops = 1.477000e+04 Mflops = 458.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000451527; expected ratio = 0.0001obtained abs = 4.18842e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00684633; expected ratio = 0.001obtained abs = 2.30153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363430e+05 Mflops = 317.88 -Solve time = 0.00 -Solve flops = 1.477000e+04 Mflops = 462.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000399111; expected ratio = 0.0001obtained abs = 3.7021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00595599; expected ratio = 0.001obtained abs = 2.00537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363430e+05 Mflops = 317.17 -Solve time = 0.00 -Solve flops = 1.477000e+04 Mflops = 462.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00034898; expected ratio = 0.0001obtained abs = 3.23703e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00557168; expected ratio = 0.001obtained abs = 1.87838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363430e+05 Mflops = 317.17 -Solve time = 0.00 -Solve flops = 1.477000e+04 Mflops = 462.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000301895; expected ratio = 0.0001obtained abs = 2.80023e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00487605; expected ratio = 0.001obtained abs = 1.64589; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.367630e+05 Mflops = 317.27 -Solve time = 0.00 -Solve flops = 1.480000e+04 Mflops = 449.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000259064; expected ratio = 0.0001obtained abs = 2.4029e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00451687; expected ratio = 0.001obtained abs = 1.52613; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.367630e+05 Mflops = 318.15 -Solve time = 0.00 -Solve flops = 1.480000e+04 Mflops = 463.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000221106; expected ratio = 0.0001obtained abs = 2.0508e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00396463; expected ratio = 0.001obtained abs = 1.3408; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.367630e+05 Mflops = 317.27 -Solve time = 0.00 -Solve flops = 1.480000e+04 Mflops = 463.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000187123; expected ratio = 0.0001obtained abs = 1.73558e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00362606; expected ratio = 0.001obtained abs = 1.22717; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.367630e+05 Mflops = 317.27 -Solve time = 0.00 -Solve flops = 1.480000e+04 Mflops = 449.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000157901; expected ratio = 0.0001obtained abs = 1.46453e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00318432; expected ratio = 0.001obtained abs = 1.07844; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.367630e+05 Mflops = 309.40 -Solve time = 0.00 -Solve flops = 1.480000e+04 Mflops = 449.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000131865; expected ratio = 0.0001obtained abs = 1.22304e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00287292; expected ratio = 0.001obtained abs = 0.973463; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.367630e+05 Mflops = 317.45 -Solve time = 0.00 -Solve flops = 1.480000e+04 Mflops = 459.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000109993; expected ratio = 0.0001obtained abs = 1.02017e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0025203; expected ratio = 0.001obtained abs = 0.854419; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.7345 - Final Residual ratio : 0.0178237 - Residual ratio : 0.000903174 - Slope : -0.730249 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.7731 - Final Residual ratio : 0.0380184 - Residual ratio : 0.000980535 - Slope : -1.5494 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.5124 - Final Residual ratio : 0.0356021 - Residual ratio : 0.000924431 - Slope : -1.53907 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.7843 - Final Residual ratio : 0.0252567 - Residual ratio : 0.000847988 - Slope : -1.10219 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.8484 - Final Residual ratio : 0.0147996 - Residual ratio : 0.000709867 - Slope : -0.744056 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.2509 - Final Residual ratio : 0.0280255 - Residual ratio : 0.000896791 - Slope : -1.1564 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 53.6784 - Final Residual ratio : 0.0398526 - Residual ratio : 0.000742433 - Slope : -2.06302 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.6926 - Final Residual ratio : 0.0365118 - Residual ratio : 0.00072026 - Slope : -2.02624 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.962 - Final Residual ratio : 0.0148783 - Residual ratio : 0.000877155 - Slope : -0.564905 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.4871 - Final Residual ratio : 0.0119068 - Residual ratio : 0.00095353 - Slope : -0.430178 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.4951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 116 - - Mesh vertices: 113 - Mesh triangles: 116 - Mesh edges: 191 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.4951 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.338200e+05 Mflops = 314.97 -Solve time = 0.00 -Solve flops = 1.462200e+04 Mflops = 441.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0473968; expected ratio = 0.0001obtained abs = 0.000449925; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.229291; expected ratio = 0.001obtained abs = 72.8515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000419855 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.348420e+05 Mflops = 320.25 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 443.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00928217; expected ratio = 0.0001obtained abs = 8.80405e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0635687; expected ratio = 0.001obtained abs = 20.2628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.352320e+05 Mflops = 317.41 -Solve time = 0.00 -Solve flops = 1.470800e+04 Mflops = 447.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00134794; expected ratio = 0.0001obtained abs = 1.27869e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0861004; expected ratio = 0.001obtained abs = 27.6918; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.351720e+05 Mflops = 315.85 -Solve time = 0.00 -Solve flops = 1.470400e+04 Mflops = 443.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00121465; expected ratio = 0.0001obtained abs = 1.15215e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0849277; expected ratio = 0.001obtained abs = 27.523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.351720e+05 Mflops = 317.26 -Solve time = 0.00 -Solve flops = 1.470400e+04 Mflops = 446.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00143595; expected ratio = 0.0001obtained abs = 1.36199e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0691234; expected ratio = 0.001obtained abs = 21.9648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.337640e+05 Mflops = 313.26 -Solve time = 0.00 -Solve flops = 1.460600e+04 Mflops = 457.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000761397; expected ratio = 0.0001obtained abs = 7.22142e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.219651; expected ratio = 0.001obtained abs = 69.04; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.340640e+05 Mflops = 314.66 -Solve time = 0.00 -Solve flops = 1.462600e+04 Mflops = 444.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000632408; expected ratio = 0.0001obtained abs = 5.99787e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.305433; expected ratio = 0.001obtained abs = 96.1788; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.339000e+05 Mflops = 314.98 -Solve time = 0.00 -Solve flops = 1.461600e+04 Mflops = 444.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000391591; expected ratio = 0.0001obtained abs = 3.71386e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.317262; expected ratio = 0.001obtained abs = 102.515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.339000e+05 Mflops = 313.58 -Solve time = 0.00 -Solve flops = 1.461600e+04 Mflops = 457.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000256563; expected ratio = 0.0001obtained abs = 2.43322e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.2072; expected ratio = 0.001obtained abs = 66.9699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.339000e+05 Mflops = 314.98 -Solve time = 0.00 -Solve flops = 1.461600e+04 Mflops = 457.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162967; expected ratio = 0.0001obtained abs = 1.54557e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127855; expected ratio = 0.001obtained abs = 41.8373; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.339000e+05 Mflops = 314.28 -Solve time = 0.00 -Solve flops = 1.461600e+04 Mflops = 457.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.60193e-05; expected ratio = 0.0001obtained abs = 9.10634e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0753568; expected ratio = 0.001obtained abs = 24.5532; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.4961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.7918 - Final Residual ratio : 0.00907643 - Residual ratio : 0.000709548 - Slope : -0.456527 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.3525 - Final Residual ratio : 0.00943737 - Residual ratio : 0.000657542 - Slope : -0.512252 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.8725 - Final Residual ratio : 0.0113581 - Residual ratio : 0.000818752 - Slope : -0.462038 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.4991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.8566 - Final Residual ratio : 0.0118521 - Residual ratio : 0.000999628 - Slope : -0.408438 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.4991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.5684 - Final Residual ratio : 0.0233143 - Residual ratio : 0.000816088 - Slope : -1.2975 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.9407 - Final Residual ratio : 0.0520527 - Residual ratio : 0.000983226 - Slope : -1.95884 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.645 - Final Residual ratio : 0.0461178 - Residual ratio : 0.000988697 - Slope : -1.86396 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.0306 - Final Residual ratio : 0.011719 - Residual ratio : 0.00083525 - Slope : -0.500673 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.88005 - Final Residual ratio : 0.00654063 - Residual ratio : 0.000662004 - Slope : -0.3185 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.338 - Final Residual ratio : 0.00855369 - Residual ratio : 0.000827405 - Slope : -0.344314 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 11 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 116 - - Mesh vertices: 113 - Mesh triangles: 116 - Mesh edges: 191 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5051 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.394640e+05 Mflops = 317.74 -Solve time = 0.00 -Solve flops = 1.491800e+04 Mflops = 450.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0563788; expected ratio = 0.0001obtained abs = 0.000544485; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0753859; expected ratio = 0.001obtained abs = 24.0911; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.394640e+05 Mflops = 319.82 -Solve time = 0.00 -Solve flops = 1.491800e+04 Mflops = 453.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00536334; expected ratio = 0.0001obtained abs = 5.17282e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.039194; expected ratio = 0.001obtained abs = 12.5372; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.394640e+05 Mflops = 314.15 -Solve time = 0.00 -Solve flops = 1.491800e+04 Mflops = 466.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0007717; expected ratio = 0.0001obtained abs = 7.4443e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0176536; expected ratio = 0.001obtained abs = 5.66997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.394640e+05 Mflops = 319.12 -Solve time = 0.00 -Solve flops = 1.491800e+04 Mflops = 453.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000190398; expected ratio = 0.0001obtained abs = 1.83663e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100535; expected ratio = 0.001obtained abs = 3.22407; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.394640e+05 Mflops = 320.00 -Solve time = 0.00 -Solve flops = 1.491800e+04 Mflops = 466.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.44172e-05; expected ratio = 0.0001obtained abs = 2.35535e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0060196; expected ratio = 0.001obtained abs = 1.9317; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.5061 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 229.613 - Final Residual ratio : 0.209239 - Residual ratio : 0.000911266 - Slope : -9.5585 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 156.809 - Final Residual ratio : 0.134909 - Residual ratio : 0.000860341 - Slope : -6.26697 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 383.155 - Final Residual ratio : 0.365503 - Residual ratio : 0.000953929 - Slope : -14.7227 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 168.575 - Final Residual ratio : 0.152258 - Residual ratio : 0.000903203 - Slope : -6.2379 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5101 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.646 - Final Residual ratio : 0.0678461 - Residual ratio : 0.000946963 - Slope : -2.46821 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.4277 - Final Residual ratio : 0.0283065 - Residual ratio : 0.000717934 - Slope : -1.3586 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.4319 - Final Residual ratio : 0.0291057 - Residual ratio : 0.000702494 - Slope : -1.38009 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.0602 - Final Residual ratio : 0.0300456 - Residual ratio : 0.000714347 - Slope : -1.40101 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.5983 - Final Residual ratio : 0.0334797 - Residual ratio : 0.000867388 - Slope : -1.48326 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.4197 - Final Residual ratio : 0.0289209 - Residual ratio : 0.000865385 - Slope : -1.11302 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 116 - - Mesh vertices: 113 - Mesh triangles: 116 - Mesh edges: 191 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5151 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.364880e+05 Mflops = 314.55 -Solve time = 0.00 -Solve flops = 1.480600e+04 Mflops = 434.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0598167; expected ratio = 0.0001obtained abs = 0.000587572; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121796; expected ratio = 0.001obtained abs = 39.0407; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.367880e+05 Mflops = 307.30 -Solve time = 0.00 -Solve flops = 1.482600e+04 Mflops = 464.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00469065; expected ratio = 0.0001obtained abs = 4.60008e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0227877; expected ratio = 0.001obtained abs = 7.37441; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.367880e+05 Mflops = 317.33 -Solve time = 0.00 -Solve flops = 1.482600e+04 Mflops = 447.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000862749; expected ratio = 0.0001obtained abs = 8.46283e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0112193; expected ratio = 0.001obtained abs = 3.6295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.367880e+05 Mflops = 315.93 -Solve time = 0.00 -Solve flops = 1.482600e+04 Mflops = 450.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000189752; expected ratio = 0.0001obtained abs = 1.86124e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162461; expected ratio = 0.001obtained abs = 5.25377; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000648022 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.360380e+05 Mflops = 315.59 -Solve time = 0.00 -Solve flops = 1.478400e+04 Mflops = 449.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.016156; expected ratio = 0.0001obtained abs = 0.000158551; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0669524; expected ratio = 0.001obtained abs = 21.9404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363260e+05 Mflops = 315.56 -Solve time = 0.00 -Solve flops = 1.480200e+04 Mflops = 449.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00427561; expected ratio = 0.0001obtained abs = 4.1966e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0337819; expected ratio = 0.001obtained abs = 11.0354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000418186 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363260e+05 Mflops = 314.86 -Solve time = 0.00 -Solve flops = 1.480200e+04 Mflops = 449.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00137298; expected ratio = 0.0001obtained abs = 1.34744e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0191597; expected ratio = 0.001obtained abs = 6.25564; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363260e+05 Mflops = 314.86 -Solve time = 0.00 -Solve flops = 1.480200e+04 Mflops = 449.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00077095; expected ratio = 0.0001obtained abs = 7.5658e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0137587; expected ratio = 0.001obtained abs = 4.49053; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363260e+05 Mflops = 315.56 -Solve time = 0.00 -Solve flops = 1.480200e+04 Mflops = 463.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000244779; expected ratio = 0.0001obtained abs = 2.40222e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0110445; expected ratio = 0.001obtained abs = 3.60605; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363260e+05 Mflops = 315.56 -Solve time = 0.00 -Solve flops = 1.480200e+04 Mflops = 449.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0001367; expected ratio = 0.0001obtained abs = 1.34156e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00897141; expected ratio = 0.001obtained abs = 2.92902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363260e+05 Mflops = 314.86 -Solve time = 0.00 -Solve flops = 1.480200e+04 Mflops = 449.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.23074e-05; expected ratio = 0.0001obtained abs = 5.13336e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00722037; expected ratio = 0.001obtained abs = 2.35724; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.5161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.5354 - Final Residual ratio : 0.023476 - Residual ratio : 0.000822698 - Slope : -0.983169 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.9772 - Final Residual ratio : 0.023467 - Residual ratio : 0.000939536 - Slope : -1.18827 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.4579 - Final Residual ratio : 0.022233 - Residual ratio : 0.000989988 - Slope : -0.747856 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.2962 - Final Residual ratio : 0.0126522 - Residual ratio : 0.000623376 - Slope : -0.676119 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.1216 - Final Residual ratio : 0.0174229 - Residual ratio : 0.000961445 - Slope : -0.624283 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2882 - Final Residual ratio : 0.0132866 - Residual ratio : 0.000815722 - Slope : -0.581245 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.9351 - Final Residual ratio : 0.0145019 - Residual ratio : 0.000970992 - Slope : -0.67821 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.948 - Final Residual ratio : 0.00815104 - Residual ratio : 0.000584389 - Slope : -0.449672 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.9097 - Final Residual ratio : 0.0122011 - Residual ratio : 0.000945107 - Slope : -0.429917 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.6581 - Final Residual ratio : 0.00843432 - Residual ratio : 0.00072347 - Slope : -0.388324 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 11 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5251 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.356560e+05 Mflops = 307.72 -Solve time = 0.00 -Solve flops = 1.478200e+04 Mflops = 459.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0676336; expected ratio = 0.0001obtained abs = 0.000678425; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102407; expected ratio = 0.001obtained abs = 32.6843; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.350620e+05 Mflops = 308.38 -Solve time = 0.00 -Solve flops = 1.474600e+04 Mflops = 448.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0100061; expected ratio = 0.0001obtained abs = 0.0001002; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0812296; expected ratio = 0.001obtained abs = 26.1106; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.350620e+05 Mflops = 308.38 -Solve time = 0.00 -Solve flops = 1.474600e+04 Mflops = 448.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0013522; expected ratio = 0.0001obtained abs = 1.35454e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0364746; expected ratio = 0.001obtained abs = 11.7577; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.350620e+05 Mflops = 308.38 -Solve time = 0.00 -Solve flops = 1.474600e+04 Mflops = 448.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000550537; expected ratio = 0.0001obtained abs = 5.51457e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0252555; expected ratio = 0.001obtained abs = 8.13457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.350620e+05 Mflops = 307.54 -Solve time = 0.00 -Solve flops = 1.474600e+04 Mflops = 461.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.89533e-05; expected ratio = 0.0001obtained abs = 8.91011e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.020365; expected ratio = 0.001obtained abs = 6.56099; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.5261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.4795 - Final Residual ratio : 0.0170412 - Residual ratio : 0.000758077 - Slope : -0.774568 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.4035 - Final Residual ratio : 0.0108164 - Residual ratio : 0.000948514 - Slope : -0.356022 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3027 - Final Residual ratio : 0.0077756 - Residual ratio : 0.000754715 - Slope : -0.332094 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0993 - Final Residual ratio : 0.0069654 - Residual ratio : 0.000689691 - Slope : -0.325559 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.48192 - Final Residual ratio : 0.00704132 - Residual ratio : 0.000742605 - Slope : -0.32672 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.46712 - Final Residual ratio : 0.00739224 - Residual ratio : 0.000873053 - Slope : -0.302133 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.64105 - Final Residual ratio : 0.00634898 - Residual ratio : 0.000830904 - Slope : -0.272668 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.44443 - Final Residual ratio : 0.00630741 - Residual ratio : 0.000847265 - Slope : -0.239939 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.58951 - Final Residual ratio : 0.00504638 - Residual ratio : 0.000664915 - Slope : -0.24466 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.47175 - Final Residual ratio : 0.00733784 - Residual ratio : 0.000982078 - Slope : -0.248814 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5351 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.00043416 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.356140e+05 Mflops = 303.36 -Solve time = 0.00 -Solve flops = 1.478600e+04 Mflops = 449.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0669069; expected ratio = 0.0001obtained abs = 0.000686086; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0185975; expected ratio = 0.001obtained abs = 5.98223; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.356140e+05 Mflops = 307.63 -Solve time = 0.00 -Solve flops = 1.478600e+04 Mflops = 459.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00644736; expected ratio = 0.0001obtained abs = 6.5968e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0203533; expected ratio = 0.001obtained abs = 6.58552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.356140e+05 Mflops = 306.80 -Solve time = 0.00 -Solve flops = 1.478600e+04 Mflops = 449.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000749159; expected ratio = 0.0001obtained abs = 7.66724e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0104158; expected ratio = 0.001obtained abs = 3.37037; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.0004282 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.356140e+05 Mflops = 306.14 -Solve time = 0.00 -Solve flops = 1.478600e+04 Mflops = 462.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000132886; expected ratio = 0.0001obtained abs = 1.35998e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00757131; expected ratio = 0.001obtained abs = 2.45017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.356140e+05 Mflops = 307.46 -Solve time = 0.00 -Solve flops = 1.478600e+04 Mflops = 462.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.17187e-05; expected ratio = 0.0001obtained abs = 2.22273e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00601792; expected ratio = 0.001obtained abs = 1.9472; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.5361 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.84026 - Final Residual ratio : 0.00487256 - Residual ratio : 0.000712336 - Slope : -0.227846 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.10996 - Final Residual ratio : 0.00384462 - Residual ratio : 0.000629238 - Slope : -0.203537 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.87967 - Final Residual ratio : 0.00289612 - Residual ratio : 0.000492565 - Slope : -0.183649 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5391 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.17776 - Final Residual ratio : 0.00382699 - Residual ratio : 0.000619479 - Slope : -0.199159 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.3923 - Final Residual ratio : 0.00628216 - Residual ratio : 0.00098277 - Slope : -0.212867 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.05389 - Final Residual ratio : 0.00477668 - Residual ratio : 0.000789026 - Slope : -0.201637 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.28954 - Final Residual ratio : 0.00511936 - Residual ratio : 0.000967826 - Slope : -0.195719 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.68688 - Final Residual ratio : 0.00434247 - Residual ratio : 0.000926515 - Slope : -0.173427 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.71866 - Final Residual ratio : 0.00333391 - Residual ratio : 0.000706539 - Slope : -0.152107 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.05655 - Final Residual ratio : 0.00347599 - Residual ratio : 0.000687424 - Slope : -0.168436 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5451 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.344260e+05 Mflops = 305.43 -Solve time = 0.00 -Solve flops = 1.471400e+04 Mflops = 447.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0625849; expected ratio = 0.0001obtained abs = 0.000655431; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0295602; expected ratio = 0.001obtained abs = 9.45535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.344260e+05 Mflops = 306.93 -Solve time = 0.00 -Solve flops = 1.471400e+04 Mflops = 447.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00535469; expected ratio = 0.0001obtained abs = 5.59679e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0262358; expected ratio = 0.001obtained abs = 8.44251; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.344260e+05 Mflops = 307.60 -Solve time = 0.00 -Solve flops = 1.471400e+04 Mflops = 460.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000807229; expected ratio = 0.0001obtained abs = 8.43879e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0125259; expected ratio = 0.001obtained abs = 4.03254; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.344260e+05 Mflops = 307.60 -Solve time = 0.00 -Solve flops = 1.471400e+04 Mflops = 460.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000122521; expected ratio = 0.0001obtained abs = 1.28079e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00841765; expected ratio = 0.001obtained abs = 2.70899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.344260e+05 Mflops = 307.60 -Solve time = 0.00 -Solve flops = 1.471400e+04 Mflops = 460.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.70807e-05; expected ratio = 0.0001obtained abs = 3.87629e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00701111; expected ratio = 0.001obtained abs = 2.25665; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.5461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.0513 - Final Residual ratio : 0.0028497 - Residual ratio : 0.000564152 - Slope : -0.168282 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5471 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.59756 - Final Residual ratio : 0.00261745 - Residual ratio : 0.000569313 - Slope : -0.164105 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.06848 - Final Residual ratio : 0.00369203 - Residual ratio : 0.000907471 - Slope : -0.135493 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.01195 - Final Residual ratio : 0.00270249 - Residual ratio : 0.000673611 - Slope : -0.12933 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5501 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.37192 - Final Residual ratio : 0.00210668 - Residual ratio : 0.000481866 - Slope : -0.150683 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.54178 - Final Residual ratio : 0.00360316 - Residual ratio : 0.000793337 - Slope : -0.151273 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.24779 - Final Residual ratio : 0.00279619 - Residual ratio : 0.000658268 - Slope : -0.1415 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.70723 - Final Residual ratio : 0.00540318 - Residual ratio : 0.000805576 - Slope : -0.231098 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.37314 - Final Residual ratio : 0.00402744 - Residual ratio : 0.000920949 - Slope : -0.161819 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.56473 - Final Residual ratio : 0.00203058 - Residual ratio : 0.000569632 - Slope : -0.114926 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5551 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000433207 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.422990e+05 Mflops = 324.90 -Solve time = 0.00 -Solve flops = 1.490600e+04 Mflops = 453.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0808318; expected ratio = 0.0001obtained abs = 0.000858236; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.207636; expected ratio = 0.001obtained abs = 60.4713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.425850e+05 Mflops = 327.88 -Solve time = 0.00 -Solve flops = 1.492800e+04 Mflops = 467.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00833148; expected ratio = 0.0001obtained abs = 8.83443e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.066679; expected ratio = 0.001obtained abs = 19.4317; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.425850e+05 Mflops = 327.70 -Solve time = 0.00 -Solve flops = 1.492800e+04 Mflops = 467.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000948192; expected ratio = 0.0001obtained abs = 1.00569e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0135521; expected ratio = 0.001obtained abs = 3.9546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.417930e+05 Mflops = 325.88 -Solve time = 0.00 -Solve flops = 1.488000e+04 Mflops = 465.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000200608; expected ratio = 0.0001obtained abs = 2.12766e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00413879; expected ratio = 0.001obtained abs = 1.20751; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.425850e+05 Mflops = 328.60 -Solve time = 0.00 -Solve flops = 1.492800e+04 Mflops = 453.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.09393e-05; expected ratio = 0.0001obtained abs = 3.28144e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00190822; expected ratio = 0.001obtained abs = 0.556632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.5561 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.0288 - Final Residual ratio : 0.0121589 - Residual ratio : 0.000347112 - Slope : -1.09427 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 74.2567 - Final Residual ratio : 0.0622727 - Residual ratio : 0.000838613 - Slope : -2.39337 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.4713 - Final Residual ratio : 0.0460567 - Residual ratio : 0.000635516 - Slope : -2.26329 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 55.9902 - Final Residual ratio : 0.0502177 - Residual ratio : 0.000896902 - Slope : -2.43217 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.3427 - Final Residual ratio : 0.0260931 - Residual ratio : 0.000698748 - Slope : -1.24389 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.5362 - Final Residual ratio : 0.0232004 - Residual ratio : 0.00090853 - Slope : -0.879757 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.5365 - Final Residual ratio : 0.0200437 - Residual ratio : 0.00081689 - Slope : -0.845397 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5631 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.3712 - Final Residual ratio : 0.0188939 - Residual ratio : 0.000690284 - Slope : -0.882334 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.469 - Final Residual ratio : 0.0191204 - Residual ratio : 0.000671621 - Slope : -1.09423 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.292 - Final Residual ratio : 0.0166498 - Residual ratio : 0.00061006 - Slope : -0.974121 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5651 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.418370e+05 Mflops = 322.97 -Solve time = 0.00 -Solve flops = 1.488200e+04 Mflops = 465.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0697325; expected ratio = 0.0001obtained abs = 0.000751147; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.364663; expected ratio = 0.001obtained abs = 136.272; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.422550e+05 Mflops = 326.22 -Solve time = 0.00 -Solve flops = 1.490400e+04 Mflops = 466.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0085821; expected ratio = 0.0001obtained abs = 9.22594e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0445885; expected ratio = 0.001obtained abs = 16.6634; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.422550e+05 Mflops = 326.94 -Solve time = 0.00 -Solve flops = 1.490400e+04 Mflops = 466.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117477; expected ratio = 0.0001obtained abs = 1.26297e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0537779; expected ratio = 0.001obtained abs = 19.8925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.424350e+05 Mflops = 326.81 -Solve time = 0.00 -Solve flops = 1.491400e+04 Mflops = 463.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00050233; expected ratio = 0.0001obtained abs = 5.40034e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0623115; expected ratio = 0.001obtained abs = 23.389; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.422550e+05 Mflops = 325.69 -Solve time = 0.00 -Solve flops = 1.490400e+04 Mflops = 463.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000434182; expected ratio = 0.0001obtained abs = 4.66772e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0404691; expected ratio = 0.001obtained abs = 15.0884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.422550e+05 Mflops = 326.40 -Solve time = 0.00 -Solve flops = 1.490400e+04 Mflops = 466.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000106128; expected ratio = 0.0001obtained abs = 1.14093e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0278017; expected ratio = 0.001obtained abs = 10.3322; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.422550e+05 Mflops = 316.87 -Solve time = 0.00 -Solve flops = 1.490400e+04 Mflops = 466.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.01735e-05; expected ratio = 0.0001obtained abs = 3.2438e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0201843; expected ratio = 0.001obtained abs = 7.50938; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.5661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.687 - Final Residual ratio : 0.0147853 - Residual ratio : 0.000598909 - Slope : -0.795879 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.248 - Final Residual ratio : 0.021123 - Residual ratio : 0.000994117 - Slope : -0.707563 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.2963 - Final Residual ratio : 0.0155793 - Residual ratio : 0.00090073 - Slope : -0.595887 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.5751 - Final Residual ratio : 0.0107166 - Residual ratio : 0.000789429 - Slope : -0.467736 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.6129 - Final Residual ratio : 0.0082383 - Residual ratio : 0.00070941 - Slope : -0.351656 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5711 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.8557 - Final Residual ratio : 0.00966983 - Residual ratio : 0.000815627 - Slope : -0.38213 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.3378 - Final Residual ratio : 0.00822633 - Residual ratio : 0.000666756 - Slope : -0.397729 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.2025 - Final Residual ratio : 0.0109616 - Residual ratio : 0.000771808 - Slope : -0.47305 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.9756 - Final Residual ratio : 0.0239912 - Residual ratio : 0.000774519 - Slope : -1.0673 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.4333 - Final Residual ratio : 0.0243272 - Residual ratio : 0.000727635 - Slope : -1.19318 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5751 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.422550e+05 Mflops = 325.51 -Solve time = 0.00 -Solve flops = 1.490400e+04 Mflops = 466.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0612016; expected ratio = 0.0001obtained abs = 0.000668279; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.423341; expected ratio = 0.001obtained abs = 120.553; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.409970e+05 Mflops = 324.94 -Solve time = 0.00 -Solve flops = 1.485600e+04 Mflops = 402.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00729303; expected ratio = 0.0001obtained abs = 7.95619e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0504317; expected ratio = 0.001obtained abs = 14.5203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.409370e+05 Mflops = 324.09 -Solve time = 0.00 -Solve flops = 1.485200e+04 Mflops = 461.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000837249; expected ratio = 0.0001obtained abs = 9.13525e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116404; expected ratio = 0.001obtained abs = 3.35852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.409370e+05 Mflops = 323.91 -Solve time = 0.00 -Solve flops = 1.485200e+04 Mflops = 464.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000114141; expected ratio = 0.0001obtained abs = 1.24536e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00704115; expected ratio = 0.001obtained abs = 2.02951; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.409370e+05 Mflops = 324.80 -Solve time = 0.00 -Solve flops = 1.485200e+04 Mflops = 461.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.61023e-05; expected ratio = 0.0001obtained abs = 2.84794e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00604128; expected ratio = 0.001obtained abs = 1.74198; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.5761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9121 - Final Residual ratio : 0.00962902 - Residual ratio : 0.000808339 - Slope : -0.396749 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.0527 - Final Residual ratio : 0.0131355 - Residual ratio : 0.000595642 - Slope : -0.734653 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5781 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.7282 - Final Residual ratio : 0.0109856 - Residual ratio : 0.000462975 - Slope : -0.790575 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.2688 - Final Residual ratio : 0.0188022 - Residual ratio : 0.000927642 - Slope : -0.698276 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.0779 - Final Residual ratio : 0.0126238 - Residual ratio : 0.000837239 - Slope : -0.538046 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5355 - Final Residual ratio : 0.010838 - Residual ratio : 0.000939527 - Slope : -0.397404 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.0691 - Final Residual ratio : 0.00634804 - Residual ratio : 0.000573492 - Slope : -0.381474 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.2475 - Final Residual ratio : 0.00660689 - Residual ratio : 0.000587411 - Slope : -0.387616 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0957 - Final Residual ratio : 0.00547279 - Residual ratio : 0.000542091 - Slope : -0.360366 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.13604 - Final Residual ratio : 0.00679933 - Residual ratio : 0.000835705 - Slope : -0.280319 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5851 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.644510e+05 Mflops = 338.28 -Solve time = 0.00 -Solve flops = 1.603200e+04 Mflops = 487.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0623055; expected ratio = 0.0001obtained abs = 0.000691297; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.25623; expected ratio = 0.001obtained abs = 91.2307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.658130e+05 Mflops = 342.60 -Solve time = 0.00 -Solve flops = 1.608600e+04 Mflops = 485.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00817465; expected ratio = 0.0001obtained abs = 9.04951e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0639778; expected ratio = 0.001obtained abs = 22.6547; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.658130e+05 Mflops = 343.27 -Solve time = 0.00 -Solve flops = 1.608600e+04 Mflops = 485.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00091723; expected ratio = 0.0001obtained abs = 1.01544e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0241572; expected ratio = 0.001obtained abs = 8.55446; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.658130e+05 Mflops = 343.27 -Solve time = 0.00 -Solve flops = 1.608600e+04 Mflops = 488.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000239826; expected ratio = 0.0001obtained abs = 2.65504e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0274479; expected ratio = 0.001obtained abs = 9.67634; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.649130e+05 Mflops = 341.41 -Solve time = 0.00 -Solve flops = 1.605600e+04 Mflops = 488.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000113739; expected ratio = 0.0001obtained abs = 1.25917e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0267184; expected ratio = 0.001obtained abs = 9.45552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.658130e+05 Mflops = 343.27 -Solve time = 0.00 -Solve flops = 1.608600e+04 Mflops = 485.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.88034e-05; expected ratio = 0.0001obtained abs = 4.29579e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0150446; expected ratio = 0.001obtained abs = 5.30904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.5861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.35119 - Final Residual ratio : 0.00640517 - Residual ratio : 0.000871311 - Slope : -0.253268 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.39598 - Final Residual ratio : 0.00417028 - Residual ratio : 0.0004967 - Slope : -0.279727 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.16767 - Final Residual ratio : 0.0070294 - Residual ratio : 0.00076676 - Slope : -0.305355 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.36528 - Final Residual ratio : 0.00588985 - Residual ratio : 0.000704083 - Slope : -0.278646 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.19352 - Final Residual ratio : 0.0045449 - Residual ratio : 0.000733816 - Slope : -0.206299 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.35289 - Final Residual ratio : 0.00257066 - Residual ratio : 0.000590565 - Slope : -0.140333 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.83194 - Final Residual ratio : 0.0031732 - Residual ratio : 0.000656714 - Slope : -0.166509 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.01097 - Final Residual ratio : 0.00540908 - Residual ratio : 0.000899869 - Slope : -0.200185 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.03023 - Final Residual ratio : 0.0056719 - Residual ratio : 0.000940578 - Slope : -0.207743 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.8098 - Final Residual ratio : 0.00424785 - Residual ratio : 0.000883164 - Slope : -0.160185 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.5951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.5951 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.652310e+05 Mflops = 337.90 -Solve time = 0.00 -Solve flops = 1.608200e+04 Mflops = 488.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0589893; expected ratio = 0.0001obtained abs = 0.000663599; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.218361; expected ratio = 0.001obtained abs = 65.682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000421762 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.648130e+05 Mflops = 339.86 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 484.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00633519; expected ratio = 0.0001obtained abs = 7.12148e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0561114; expected ratio = 0.001obtained abs = 17.1275; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.648130e+05 Mflops = 340.53 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 484.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000835824; expected ratio = 0.0001obtained abs = 9.39629e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0183819; expected ratio = 0.001obtained abs = 5.61079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.648130e+05 Mflops = 340.53 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000102487; expected ratio = 0.0001obtained abs = 1.15213e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00718586; expected ratio = 0.001obtained abs = 2.19254; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.648130e+05 Mflops = 340.53 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.95661e-05; expected ratio = 0.0001obtained abs = 2.19955e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00485823; expected ratio = 0.001obtained abs = 1.48266; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.5961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.41297 - Final Residual ratio : 0.00316483 - Residual ratio : 0.000927293 - Slope : -0.11366 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.8803 - Final Residual ratio : 0.00294358 - Residual ratio : 0.000758596 - Slope : -0.133702 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.15563 - Final Residual ratio : 0.00507554 - Residual ratio : 0.000984467 - Slope : -0.171685 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.5991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.57117 - Final Residual ratio : 0.00511974 - Residual ratio : 0.00091897 - Slope : -0.185535 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.5991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.7712 - Final Residual ratio : 0.00417288 - Residual ratio : 0.000874597 - Slope : -0.16438 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.31513 - Final Residual ratio : 0.00217366 - Residual ratio : 0.000655679 - Slope : -0.110432 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.60036 - Final Residual ratio : 0.00173661 - Residual ratio : 0.000667835 - Slope : -0.0866207 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6031 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.33215 - Final Residual ratio : 0.00197581 - Residual ratio : 0.000592953 - Slope : -0.107425 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.95221 - Final Residual ratio : 0.00306987 - Residual ratio : 0.000776748 - Slope : -0.131638 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.76169 - Final Residual ratio : 0.00246741 - Residual ratio : 0.000655931 - Slope : -0.125307 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6051 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.483700e+05 Mflops = 331.90 -Solve time = 0.00 -Solve flops = 1.528200e+04 Mflops = 464.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0585443; expected ratio = 0.0001obtained abs = 0.000670918; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109395; expected ratio = 0.001obtained abs = 36.4244; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.486400e+05 Mflops = 325.22 -Solve time = 0.00 -Solve flops = 1.530600e+04 Mflops = 479.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00659159; expected ratio = 0.0001obtained abs = 7.53945e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0288272; expected ratio = 0.001obtained abs = 9.60002; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.486400e+05 Mflops = 333.21 -Solve time = 0.00 -Solve flops = 1.530600e+04 Mflops = 465.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000941975; expected ratio = 0.0001obtained abs = 1.07743e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0180617; expected ratio = 0.001obtained abs = 6.0069; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.486400e+05 Mflops = 333.93 -Solve time = 0.00 -Solve flops = 1.530600e+04 Mflops = 479.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000218808; expected ratio = 0.0001obtained abs = 2.5027e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103193; expected ratio = 0.001obtained abs = 3.43424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.495400e+05 Mflops = 334.52 -Solve time = 0.00 -Solve flops = 1.533600e+04 Mflops = 476.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.95459e-05; expected ratio = 0.0001obtained abs = 6.81084e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0173879; expected ratio = 0.001obtained abs = 5.78648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.85316 - Final Residual ratio : 0.00245249 - Residual ratio : 0.000859571 - Slope : -0.0983001 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 252.158 - Final Residual ratio : 0.251428 - Residual ratio : 0.000997105 - Slope : -13.2583 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 126.286 - Final Residual ratio : 0.117935 - Residual ratio : 0.000933873 - Slope : -5.48557 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.9502 - Final Residual ratio : 0.033588 - Residual ratio : 0.000885055 - Slope : -1.30747 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.473 - Final Residual ratio : 0.0154011 - Residual ratio : 0.000790896 - Slope : -0.670951 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.7093 - Final Residual ratio : 0.0140635 - Residual ratio : 0.000794126 - Slope : -0.655381 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.8552 - Final Residual ratio : 0.0145743 - Residual ratio : 0.000864675 - Slope : -0.623726 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6131 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.3877 - Final Residual ratio : 0.0130312 - Residual ratio : 0.000846858 - Slope : -0.854147 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.6556 - Final Residual ratio : 0.00783142 - Residual ratio : 0.000573494 - Slope : -0.470613 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6151 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0041 - Final Residual ratio : 0.010606 - Residual ratio : 0.000883536 - Slope : -0.428337 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6151 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.506350e+05 Mflops = 319.90 -Solve time = 0.00 -Solve flops = 1.542400e+04 Mflops = 479.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0561977; expected ratio = 0.0001obtained abs = 0.000655103; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0822337; expected ratio = 0.001obtained abs = 25.7202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.506510e+05 Mflops = 321.89 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 483.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00655067; expected ratio = 0.0001obtained abs = 7.62448e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0392549; expected ratio = 0.001obtained abs = 12.3929; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.506510e+05 Mflops = 321.24 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 497.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0007663; expected ratio = 0.0001obtained abs = 8.92072e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0164526; expected ratio = 0.001obtained abs = 5.191; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.506510e+05 Mflops = 322.55 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 483.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000111042; expected ratio = 0.0001obtained abs = 1.29263e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00927444; expected ratio = 0.001obtained abs = 2.92661; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.506510e+05 Mflops = 322.55 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 483.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.9998e-05; expected ratio = 0.0001obtained abs = 2.32796e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00737585; expected ratio = 0.001obtained abs = 2.32732; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.5861 - Final Residual ratio : 0.00693056 - Residual ratio : 0.000654686 - Slope : -0.364798 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.38847 - Final Residual ratio : 0.00554785 - Residual ratio : 0.000590922 - Slope : -0.360882 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.4259 - Final Residual ratio : 0.00564637 - Residual ratio : 0.00067012 - Slope : -0.290354 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.7237 - Final Residual ratio : 0.0042952 - Residual ratio : 0.000556107 - Slope : -0.275693 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.22071 - Final Residual ratio : 0.00346685 - Residual ratio : 0.000480126 - Slope : -0.248871 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.76192 - Final Residual ratio : 0.00539088 - Residual ratio : 0.000797241 - Slope : -0.241305 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.27992 - Final Residual ratio : 0.00431248 - Residual ratio : 0.00068671 - Slope : -0.23243 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.81775 - Final Residual ratio : 0.00378713 - Residual ratio : 0.00065096 - Slope : -0.223614 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.45455 - Final Residual ratio : 0.00460704 - Residual ratio : 0.000844623 - Slope : -0.209613 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.2009 - Final Residual ratio : 0.00384425 - Residual ratio : 0.000739149 - Slope : -0.185609 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 111 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 111 - - Mesh vertices: 111 - Mesh triangles: 165 - Mesh edges: 275 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 165 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 111 - Input triangles: 113 - - Mesh vertices: 112 - Mesh triangles: 115 - Mesh edges: 189 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6251 -matrix_partition : [5](0,47,94,141,189) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.475270e+05 Mflops = 322.78 -Solve time = 0.00 -Solve flops = 1.511000e+04 Mflops = 472.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0580673; expected ratio = 0.0001obtained abs = 0.000695135; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0435218; expected ratio = 0.001obtained abs = 13.9012; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.475270e+05 Mflops = 324.82 -Solve time = 0.00 -Solve flops = 1.511000e+04 Mflops = 472.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00571353; expected ratio = 0.0001obtained abs = 6.82823e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0146383; expected ratio = 0.001obtained abs = 4.69946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.480970e+05 Mflops = 325.56 -Solve time = 0.00 -Solve flops = 1.514000e+04 Mflops = 473.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000601572; expected ratio = 0.0001obtained abs = 7.18968e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00819302; expected ratio = 0.001obtained abs = 2.62975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.480970e+05 Mflops = 325.39 -Solve time = 0.00 -Solve flops = 1.514000e+04 Mflops = 473.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.97755e-05; expected ratio = 0.0001obtained abs = 1.07296e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00441498; expected ratio = 0.001obtained abs = 1.41698; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.85495 - Final Residual ratio : 0.00332197 - Residual ratio : 0.000684244 - Slope : -0.173273 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.6271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.46183 - Final Residual ratio : 0.00394321 - Residual ratio : 0.000883766 - Slope : -0.165107 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.09238 - Final Residual ratio : 0.00357318 - Residual ratio : 0.00087313 - Slope : -0.170367 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.88278 - Final Residual ratio : 0.00374981 - Residual ratio : 0.000965755 - Slope : -0.184716 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.87664 - Final Residual ratio : 0.00292342 - Residual ratio : 0.000754111 - Slope : -0.133576 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.78854 - Final Residual ratio : 0.00187151 - Residual ratio : 0.000493991 - Slope : -0.130575 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.61881 - Final Residual ratio : 0.00320596 - Residual ratio : 0.000885915 - Slope : -0.129129 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.35462 - Final Residual ratio : 0.00206631 - Residual ratio : 0.000615961 - Slope : -0.124168 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11602 - Final Residual ratio : 0.00270779 - Residual ratio : 0.000868989 - Slope : -0.129722 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.88162 - Final Residual ratio : 0.00389277 - Residual ratio : 0.000565676 - Slope : -0.237163 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 112 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 112 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - - Mesh vertices: 112 - Mesh triangles: 167 - Mesh edges: 278 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 167 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - Input triangles: 115 - - Mesh vertices: 112 - Mesh triangles: 115 - Mesh edges: 189 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6351 -matrix_partition : [5](0,47,94,141,189) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.474670e+05 Mflops = 322.82 -Solve time = 0.00 -Solve flops = 1.509800e+04 Mflops = 455.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0558476; expected ratio = 0.0001obtained abs = 0.000680593; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0385315; expected ratio = 0.001obtained abs = 12.4518; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.476470e+05 Mflops = 325.25 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 487.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00600454; expected ratio = 0.0001obtained abs = 7.30218e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118063; expected ratio = 0.001obtained abs = 3.82336; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.476470e+05 Mflops = 326.62 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 472.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000921527; expected ratio = 0.0001obtained abs = 1.12079e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00586558; expected ratio = 0.001obtained abs = 1.89921; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.476470e+05 Mflops = 325.93 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 472.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000272807; expected ratio = 0.0001obtained abs = 3.31793e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0041753; expected ratio = 0.001obtained abs = 1.35196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.476470e+05 Mflops = 325.25 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 469.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000136726; expected ratio = 0.0001obtained abs = 1.6629e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00341122; expected ratio = 0.001obtained abs = 1.10458; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 189 -RHS size in solver: 189 -Factor time = 0.00 -Factor flops = 1.476470e+05 Mflops = 325.93 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 472.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.55575e-05; expected ratio = 0.0001obtained abs = 1.04057e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00308279; expected ratio = 0.001obtained abs = 0.99817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.7419 - Final Residual ratio : 0.0168642 - Residual ratio : 0.000681606 - Slope : -0.797583 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 51.2834 - Final Residual ratio : 0.0313151 - Residual ratio : 0.000610629 - Slope : -1.76731 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.1224 - Final Residual ratio : 0.0380572 - Residual ratio : 0.000759286 - Slope : -1.72704 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.5756 - Final Residual ratio : 0.033074 - Residual ratio : 0.000835717 - Slope : -1.36354 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.7249 - Final Residual ratio : 0.0262885 - Residual ratio : 0.000948192 - Slope : -0.955124 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.6733 - Final Residual ratio : 0.0144788 - Residual ratio : 0.000735963 - Slope : -0.655294 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.2263 - Final Residual ratio : 0.0117145 - Residual ratio : 0.000680039 - Slope : -0.593606 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.101 - Final Residual ratio : 0.0103589 - Residual ratio : 0.000605751 - Slope : -0.589333 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2345 - Final Residual ratio : 0.0135284 - Residual ratio : 0.000833309 - Slope : -0.559345 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.7955 - Final Residual ratio : 0.0147883 - Residual ratio : 0.000999518 - Slope : -0.509678 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 112 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 112 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - - Mesh vertices: 112 - Mesh triangles: 167 - Mesh edges: 278 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 167 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - Input triangles: 115 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6451 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 2.286400e+05 Mflops = 401.92 -Solve time = 0.00 -Solve flops = 1.842200e+04 Mflops = 525.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0553758; expected ratio = 0.0001obtained abs = 0.000682893; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0417842; expected ratio = 0.001obtained abs = 13.6424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 2.286400e+05 Mflops = 404.64 -Solve time = 0.00 -Solve flops = 1.842200e+04 Mflops = 511.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00520584; expected ratio = 0.0001obtained abs = 6.40885e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0216639; expected ratio = 0.001obtained abs = 7.11998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 2.286400e+05 Mflops = 398.25 -Solve time = 0.00 -Solve flops = 1.842200e+04 Mflops = 529.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000657423; expected ratio = 0.0001obtained abs = 8.09413e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0219274; expected ratio = 0.001obtained abs = 7.20946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 2.286400e+05 Mflops = 397.59 -Solve time = 0.00 -Solve flops = 1.842200e+04 Mflops = 525.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000102994; expected ratio = 0.0001obtained abs = 1.26804e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136973; expected ratio = 0.001obtained abs = 4.50158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 2.286400e+05 Mflops = 405.32 -Solve time = 0.00 -Solve flops = 1.842200e+04 Mflops = 511.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.67229e-05; expected ratio = 0.0001obtained abs = 3.29007e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0087634; expected ratio = 0.001obtained abs = 2.88018; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.0865 - Final Residual ratio : 0.0112508 - Residual ratio : 0.000798692 - Slope : -0.45404 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.1768 - Final Residual ratio : 0.0100652 - Residual ratio : 0.000709976 - Slope : -0.456993 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.5828 - Final Residual ratio : 0.0088809 - Residual ratio : 0.000653833 - Slope : -0.437869 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.4379 - Final Residual ratio : 0.00915972 - Residual ratio : 0.000800819 - Slope : -0.380959 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.42295 - Final Residual ratio : 0.005121 - Residual ratio : 0.000607982 - Slope : -0.280594 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6511 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.87334 - Final Residual ratio : 0.00531905 - Residual ratio : 0.000773867 - Slope : -0.221549 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.70056 - Final Residual ratio : 0.00461749 - Residual ratio : 0.00059963 - Slope : -0.256532 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.45902 - Final Residual ratio : 0.00581517 - Residual ratio : 0.000687452 - Slope : -0.272684 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.60203 - Final Residual ratio : 0.00466652 - Residual ratio : 0.000613853 - Slope : -0.245076 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.58803 - Final Residual ratio : 0.00484731 - Residual ratio : 0.000867446 - Slope : -0.192523 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6551 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.395760e+05 Mflops = 310.90 -Solve time = 0.00 -Solve flops = 1.500400e+04 Mflops = 452.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0541768; expected ratio = 0.0001obtained abs = 0.000678144; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0665058; expected ratio = 0.001obtained abs = 21.1194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.395760e+05 Mflops = 312.23 -Solve time = 0.00 -Solve flops = 1.500400e+04 Mflops = 484.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00534158; expected ratio = 0.0001obtained abs = 6.67463e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0199743; expected ratio = 0.001obtained abs = 6.38619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.395760e+05 Mflops = 312.23 -Solve time = 0.00 -Solve flops = 1.500400e+04 Mflops = 469.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000568604; expected ratio = 0.0001obtained abs = 7.10568e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0082262; expected ratio = 0.001obtained abs = 2.63028; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.395760e+05 Mflops = 312.89 -Solve time = 0.00 -Solve flops = 1.500400e+04 Mflops = 484.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.21077e-05; expected ratio = 0.0001obtained abs = 7.76136e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00302735; expected ratio = 0.001obtained abs = 0.967899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.889 - Final Residual ratio : 0.00575328 - Residual ratio : 0.000414234 - Slope : -0.462773 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.1843 - Final Residual ratio : 0.00714831 - Residual ratio : 0.000639138 - Slope : -0.385419 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.4841 - Final Residual ratio : 0.00933121 - Residual ratio : 0.000747449 - Slope : -0.415825 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.2607 - Final Residual ratio : 0.0089105 - Residual ratio : 0.000791291 - Slope : -0.37506 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.10152 - Final Residual ratio : 0.00731826 - Residual ratio : 0.000804071 - Slope : -0.313593 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.88572 - Final Residual ratio : 0.00639961 - Residual ratio : 0.000929403 - Slope : -0.343966 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.87874 - Final Residual ratio : 0.00396819 - Residual ratio : 0.000675006 - Slope : -0.189509 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.01543 - Final Residual ratio : 0.00420095 - Residual ratio : 0.000698363 - Slope : -0.19391 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.96073 - Final Residual ratio : 0.00461443 - Residual ratio : 0.000774138 - Slope : -0.198537 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.1946 - Final Residual ratio : 0.00308911 - Residual ratio : 0.000594677 - Slope : -0.179018 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 192 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6651 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000429869 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.569730e+05 Mflops = 329.69 -Solve time = 0.00 -Solve flops = 1.574800e+04 Mflops = 461.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0536546; expected ratio = 0.0001obtained abs = 0.000680906; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0184117; expected ratio = 0.001obtained abs = 5.9104; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.569730e+05 Mflops = 331.18 -Solve time = 0.00 -Solve flops = 1.574800e+04 Mflops = 478.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00524383; expected ratio = 0.0001obtained abs = 6.6436e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116175; expected ratio = 0.001obtained abs = 3.75153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.569730e+05 Mflops = 331.85 -Solve time = 0.00 -Solve flops = 1.574800e+04 Mflops = 478.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000664352; expected ratio = 0.0001obtained abs = 8.4175e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00764895; expected ratio = 0.001obtained abs = 2.46953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000478983 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.569730e+05 Mflops = 331.85 -Solve time = 0.00 -Solve flops = 1.574800e+04 Mflops = 478.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000102689; expected ratio = 0.0001obtained abs = 1.30109e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00506878; expected ratio = 0.001obtained abs = 1.63655; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.569730e+05 Mflops = 331.18 -Solve time = 0.00 -Solve flops = 1.574800e+04 Mflops = 475.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.53661e-05; expected ratio = 0.0001obtained abs = 3.21393e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00436431; expected ratio = 0.001obtained abs = 1.40902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.09791 - Final Residual ratio : 0.00324749 - Residual ratio : 0.000792477 - Slope : -0.141195 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.84714 - Final Residual ratio : 0.0025224 - Residual ratio : 0.000655656 - Slope : -0.128154 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.47824 - Final Residual ratio : 0.00300303 - Residual ratio : 0.000670583 - Slope : -0.154319 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.93559 - Final Residual ratio : 0.00312722 - Residual ratio : 0.000633607 - Slope : -0.176159 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.65057 - Final Residual ratio : 0.00259172 - Residual ratio : 0.000557291 - Slope : -0.165999 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.85848 - Final Residual ratio : 0.00264232 - Residual ratio : 0.00068481 - Slope : -0.142809 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.10672 - Final Residual ratio : 0.00185186 - Residual ratio : 0.000596082 - Slope : -0.107065 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.01147 - Final Residual ratio : 0.00300026 - Residual ratio : 0.000996279 - Slope : -0.100282 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.1759 - Final Residual ratio : 0.0115926 - Residual ratio : 0.000952091 - Slope : -0.45053 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 61.0262 - Final Residual ratio : 0.0601094 - Residual ratio : 0.000984976 - Slope : -2.10228 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 113 - Mesh triangles: 118 - Mesh edges: 193 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6751 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.956400e+05 Mflops = 387.43 -Solve time = 0.00 -Solve flops = 1.712400e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0638773; expected ratio = 0.0001obtained abs = 0.000822276; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0666545; expected ratio = 0.001obtained abs = 22.0293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.956400e+05 Mflops = 388.90 -Solve time = 0.00 -Solve flops = 1.712400e+04 Mflops = 505.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00502574; expected ratio = 0.0001obtained abs = 6.45988e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0181211; expected ratio = 0.001obtained abs = 6.04815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.956400e+05 Mflops = 389.82 -Solve time = 0.00 -Solve flops = 1.712400e+04 Mflops = 488.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000650965; expected ratio = 0.0001obtained abs = 8.36763e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00796898; expected ratio = 0.001obtained abs = 2.66014; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.956400e+05 Mflops = 389.64 -Solve time = 0.00 -Solve flops = 1.712400e+04 Mflops = 505.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000111037; expected ratio = 0.0001obtained abs = 1.42728e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0030774; expected ratio = 0.001obtained abs = 1.02716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.956400e+05 Mflops = 389.64 -Solve time = 0.00 -Solve flops = 1.712400e+04 Mflops = 502.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.97561e-05; expected ratio = 0.0001obtained abs = 3.82489e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00223915; expected ratio = 0.001obtained abs = 0.747374; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6761 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.6259 - Final Residual ratio : 0.0606616 - Residual ratio : 0.000871249 - Slope : -2.3988 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6771 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 169.605 - Final Residual ratio : 0.156446 - Residual ratio : 0.000922412 - Slope : -6.27587 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 57.2773 - Final Residual ratio : 0.056811 - Residual ratio : 0.000991859 - Slope : -4.40157 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.8784 - Final Residual ratio : 0.0249056 - Residual ratio : 0.000735146 - Slope : -1.16736 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.374 - Final Residual ratio : 0.0222954 - Residual ratio : 0.000688682 - Slope : -1.07839 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.6854 - Final Residual ratio : 0.0232727 - Residual ratio : 0.000840612 - Slope : -0.92207 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.0679 - Final Residual ratio : 0.0333965 - Residual ratio : 0.000854832 - Slope : -1.34602 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.0052 - Final Residual ratio : 0.0175441 - Residual ratio : 0.000923119 - Slope : -0.678131 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.3624 - Final Residual ratio : 0.0181973 - Residual ratio : 0.000778915 - Slope : -0.804973 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.1873 - Final Residual ratio : 0.0096815 - Residual ratio : 0.000794393 - Slope : -0.40592 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 113 - Mesh triangles: 118 - Mesh edges: 193 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6851 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.953340e+05 Mflops = 386.82 -Solve time = 0.00 -Solve flops = 1.710600e+04 Mflops = 488.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0524174; expected ratio = 0.0001obtained abs = 0.000682591; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134414; expected ratio = 0.001obtained abs = 41.928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.953340e+05 Mflops = 386.82 -Solve time = 0.00 -Solve flops = 1.710600e+04 Mflops = 505.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00516086; expected ratio = 0.0001obtained abs = 6.71152e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.022142; expected ratio = 0.001obtained abs = 6.94954; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.953340e+05 Mflops = 387.55 -Solve time = 0.00 -Solve flops = 1.710600e+04 Mflops = 488.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000584104; expected ratio = 0.0001obtained abs = 7.59629e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00974359; expected ratio = 0.001obtained abs = 3.05858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.953340e+05 Mflops = 386.82 -Solve time = 0.00 -Solve flops = 1.710600e+04 Mflops = 501.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.68382e-05; expected ratio = 0.0001obtained abs = 8.69233e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00329794; expected ratio = 0.001obtained abs = 1.03513; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0847 - Final Residual ratio : 0.00751137 - Residual ratio : 0.000744828 - Slope : -0.335906 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.4346 - Final Residual ratio : 0.00548464 - Residual ratio : 0.000650256 - Slope : -0.290659 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.46493 - Final Residual ratio : 0.00551067 - Residual ratio : 0.000852394 - Slope : -0.258377 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.10955 - Final Residual ratio : 0.00309807 - Residual ratio : 0.000606329 - Slope : -0.170215 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.79734 - Final Residual ratio : 0.0029399 - Residual ratio : 0.00061282 - Slope : -0.165324 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.78511 - Final Residual ratio : 0.0037239 - Residual ratio : 0.000778225 - Slope : -0.170764 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.38568 - Final Residual ratio : 0.00331313 - Residual ratio : 0.000755443 - Slope : -0.156513 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.69192 - Final Residual ratio : 0.00289333 - Residual ratio : 0.000783693 - Slope : -0.141886 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.20716 - Final Residual ratio : 0.00251022 - Residual ratio : 0.000782691 - Slope : -0.106822 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.21291 - Final Residual ratio : 0.00178552 - Residual ratio : 0.000555732 - Slope : -0.107038 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.6951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 113 - Mesh triangles: 118 - Mesh edges: 193 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.6951 -matrix_partition : [5](0,48,96,144,192) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.346040e+05 Mflops = 319.69 -Solve time = 0.00 -Solve flops = 1.461000e+04 Mflops = 457.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0530399; expected ratio = 0.0001obtained abs = 0.000699034; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10788; expected ratio = 0.001obtained abs = 36.1299; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.363140e+05 Mflops = 325.41 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 456.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00560751; expected ratio = 0.0001obtained abs = 7.37714e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0167451; expected ratio = 0.001obtained abs = 5.63588; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.335440e+05 Mflops = 318.80 -Solve time = 0.00 -Solve flops = 1.455600e+04 Mflops = 455.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107612; expected ratio = 0.0001obtained abs = 1.41567e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00607814; expected ratio = 0.001obtained abs = 2.04286; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.354340e+05 Mflops = 323.86 -Solve time = 0.00 -Solve flops = 1.465000e+04 Mflops = 458.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000253308; expected ratio = 0.0001obtained abs = 3.33223e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00546224; expected ratio = 0.001obtained abs = 1.83691; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 192 -RHS size in solver: 192 -Factor time = 0.00 -Factor flops = 1.354340e+05 Mflops = 324.79 -Solve time = 0.00 -Solve flops = 1.465000e+04 Mflops = 458.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.51035e-05; expected ratio = 0.0001obtained abs = 7.24877e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00525597; expected ratio = 0.001obtained abs = 1.76718; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.6961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.38942 - Final Residual ratio : 0.00334389 - Residual ratio : 0.000986568 - Slope : -0.116761 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36397 - Final Residual ratio : 0.00311871 - Residual ratio : 0.000927092 - Slope : -0.115891 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.09903 - Final Residual ratio : 0.00253883 - Residual ratio : 0.000819234 - Slope : -0.114685 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.6991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.77141 - Final Residual ratio : 0.00179422 - Residual ratio : 0.000647402 - Slope : -0.0923206 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.6991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.53532 - Final Residual ratio : 0.00243848 - Residual ratio : 0.000961805 - Slope : -0.0873407 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.37752 - Final Residual ratio : 0.00195949 - Residual ratio : 0.000824174 - Slope : -0.0819159 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.20014 - Final Residual ratio : 0.0015072 - Residual ratio : 0.00068505 - Slope : -0.0758149 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00903 - Final Residual ratio : 0.00124569 - Residual ratio : 0.000620045 - Slope : -0.0692338 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.91841 - Final Residual ratio : 0.00108223 - Residual ratio : 0.000564129 - Slope : -0.0563921 - Tolerance : 0.001 - Number of iterations : 34 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.97212 - Final Residual ratio : 0.00145691 - Residual ratio : 0.000738756 - Slope : -0.0679538 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 119 - - Mesh vertices: 113 - Mesh triangles: 119 - Mesh edges: 195 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7051 -matrix_partition : [5](0,48,96,144,193) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.387050e+05 Mflops = 306.84 -Solve time = 0.00 -Solve flops = 1.496000e+04 Mflops = 454.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0773401; expected ratio = 0.0001obtained abs = 0.00102992; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121633; expected ratio = 0.001obtained abs = 41.3314; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.380270e+05 Mflops = 307.45 -Solve time = 0.00 -Solve flops = 1.492800e+04 Mflops = 453.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00846198; expected ratio = 0.0001obtained abs = 0.000112454; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0293016; expected ratio = 0.001obtained abs = 10.1207; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.377110e+05 Mflops = 305.93 -Solve time = 0.00 -Solve flops = 1.495000e+04 Mflops = 454.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00461741; expected ratio = 0.0001obtained abs = 6.13048e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0185095; expected ratio = 0.001obtained abs = 6.39438; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.377110e+05 Mflops = 306.58 -Solve time = 0.00 -Solve flops = 1.495000e+04 Mflops = 454.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00113727; expected ratio = 0.0001obtained abs = 1.50954e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0131351; expected ratio = 0.001obtained abs = 4.53458; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.390770e+05 Mflops = 307.02 -Solve time = 0.00 -Solve flops = 1.501200e+04 Mflops = 406.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000417286; expected ratio = 0.0001obtained abs = 5.53831e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0132914; expected ratio = 0.001obtained abs = 4.59106; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.390770e+05 Mflops = 308.31 -Solve time = 0.00 -Solve flops = 1.501200e+04 Mflops = 456.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000153058; expected ratio = 0.0001obtained abs = 2.03136e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.013828; expected ratio = 0.001obtained abs = 4.77336; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.390770e+05 Mflops = 307.66 -Solve time = 0.00 -Solve flops = 1.501200e+04 Mflops = 452.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.13459e-05; expected ratio = 0.0001obtained abs = 1.0796e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0140746; expected ratio = 0.001obtained abs = 4.86197; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.8095 - Final Residual ratio : 0.0127018 - Residual ratio : 0.0007132 - Slope : -0.593228 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.442 - Final Residual ratio : 0.0215464 - Residual ratio : 0.000575462 - Slope : -1.24735 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.9265 - Final Residual ratio : 0.0203295 - Residual ratio : 0.000522254 - Slope : -1.29687 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.2292 - Final Residual ratio : 0.0207318 - Residual ratio : 0.000623902 - Slope : -1.10695 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.533 - Final Residual ratio : 0.021292 - Residual ratio : 0.000833901 - Slope : -0.750344 - Tolerance : 0.001 - Number of iterations : 34 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7111 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.7149 - Final Residual ratio : 0.0161234 - Residual ratio : 0.00081783 - Slope : -0.656626 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.6421 - Final Residual ratio : 0.0105984 - Residual ratio : 0.000600743 - Slope : -0.587716 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.4418 - Final Residual ratio : 0.0116501 - Residual ratio : 0.00066794 - Slope : -0.601041 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7141 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.7359 - Final Residual ratio : 0.00653111 - Residual ratio : 0.000390245 - Slope : -0.597479 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.3259 - Final Residual ratio : 0.00105646 - Residual ratio : 6.89332e-05 - Slope : -0.510828 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 119 - - Mesh vertices: 113 - Mesh triangles: 119 - Mesh edges: 195 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7151 -matrix_partition : [5](0,48,96,144,193) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.366610e+05 Mflops = 303.76 -Solve time = 0.00 -Solve flops = 1.486600e+04 Mflops = 448.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0739663; expected ratio = 0.0001obtained abs = 0.000991259; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.247288; expected ratio = 0.001obtained abs = 74.3868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.380930e+05 Mflops = 306.94 -Solve time = 0.00 -Solve flops = 1.492800e+04 Mflops = 450.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.020666; expected ratio = 0.0001obtained abs = 0.000277051; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0884945; expected ratio = 0.001obtained abs = 26.873; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.378230e+05 Mflops = 306.99 -Solve time = 0.00 -Solve flops = 1.491800e+04 Mflops = 450.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00191299; expected ratio = 0.0001obtained abs = 2.56527e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0326077; expected ratio = 0.001obtained abs = 9.90612; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.378230e+05 Mflops = 306.83 -Solve time = 0.00 -Solve flops = 1.491800e+04 Mflops = 453.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000240253; expected ratio = 0.0001obtained abs = 3.22153e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0265232; expected ratio = 0.001obtained abs = 8.0615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.378230e+05 Mflops = 306.99 -Solve time = 0.00 -Solve flops = 1.491800e+04 Mflops = 450.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.27709e-05; expected ratio = 0.0001obtained abs = 1.10987e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0241332; expected ratio = 0.001obtained abs = 7.32701; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.5678 - Final Residual ratio : 0.0100971 - Residual ratio : 0.000574753 - Slope : -0.548678 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.6903 - Final Residual ratio : 0.00771666 - Residual ratio : 0.000563658 - Slope : -0.471814 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8875 - Final Residual ratio : 0.00801147 - Residual ratio : 0.000621645 - Slope : -0.444122 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.0424 - Final Residual ratio : 0.00684161 - Residual ratio : 0.000619579 - Slope : -0.380535 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.56722 - Final Residual ratio : 0.0035274 - Residual ratio : 0.000411732 - Slope : -0.305846 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.8343 - Final Residual ratio : 0.00478258 - Residual ratio : 0.000699791 - Slope : -0.2355 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7221 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.9373 - Final Residual ratio : 0.00646829 - Residual ratio : 0.000932393 - Slope : -0.256697 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.58848 - Final Residual ratio : 0.00613516 - Residual ratio : 0.000808483 - Slope : -0.26146 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.3527 - Final Residual ratio : 0.00521887 - Residual ratio : 0.000709789 - Slope : -0.244916 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.13852 - Final Residual ratio : 0.00518703 - Residual ratio : 0.000844997 - Slope : -0.219048 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 113 - Mesh triangles: 118 - Mesh edges: 194 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7251 -matrix_partition : [5](0,48,96,144,193) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.353090e+05 Mflops = 301.40 -Solve time = 0.00 -Solve flops = 1.472600e+04 Mflops = 457.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0558883; expected ratio = 0.0001obtained abs = 0.000758429; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.175645; expected ratio = 0.001obtained abs = 59.6778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.335170e+05 Mflops = 301.41 -Solve time = 0.00 -Solve flops = 1.464400e+04 Mflops = 458.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00907001; expected ratio = 0.0001obtained abs = 0.000123283; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0490015; expected ratio = 0.001obtained abs = 16.8196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.335170e+05 Mflops = 296.77 -Solve time = 0.00 -Solve flops = 1.464400e+04 Mflops = 458.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00324117; expected ratio = 0.0001obtained abs = 4.40092e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0424593; expected ratio = 0.001obtained abs = 14.569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.335170e+05 Mflops = 301.41 -Solve time = 0.00 -Solve flops = 1.464400e+04 Mflops = 458.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117836; expected ratio = 0.0001obtained abs = 1.60035e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0357723; expected ratio = 0.001obtained abs = 12.2231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.341470e+05 Mflops = 298.81 -Solve time = 0.00 -Solve flops = 1.467400e+04 Mflops = 459.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00235139; expected ratio = 0.0001obtained abs = 3.19275e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0291085; expected ratio = 0.001obtained abs = 10; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.341470e+05 Mflops = 300.24 -Solve time = 0.00 -Solve flops = 1.467400e+04 Mflops = 455.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00552797; expected ratio = 0.0001obtained abs = 7.50367e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0434431; expected ratio = 0.001obtained abs = 14.8888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.341470e+05 Mflops = 300.08 -Solve time = 0.00 -Solve flops = 1.467400e+04 Mflops = 473.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00794794; expected ratio = 0.0001obtained abs = 0.000107825; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0253772; expected ratio = 0.001obtained abs = 8.74708; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.341470e+05 Mflops = 300.08 -Solve time = 0.00 -Solve flops = 1.467400e+04 Mflops = 459.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00567275; expected ratio = 0.0001obtained abs = 7.69101e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0258877; expected ratio = 0.001obtained abs = 8.92887; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.341470e+05 Mflops = 300.08 -Solve time = 0.00 -Solve flops = 1.467400e+04 Mflops = 459.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00250082; expected ratio = 0.0001obtained abs = 3.38941e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0143566; expected ratio = 0.001obtained abs = 4.95755; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.341470e+05 Mflops = 300.72 -Solve time = 0.00 -Solve flops = 1.467400e+04 Mflops = 459.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00086824; expected ratio = 0.0001obtained abs = 1.1766e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0134152; expected ratio = 0.001obtained abs = 4.63363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 299.86 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 456.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000326489; expected ratio = 0.0001obtained abs = 4.4244e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115159; expected ratio = 0.001obtained abs = 3.97664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 299.86 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 459.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000422715; expected ratio = 0.0001obtained abs = 5.72851e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106987; expected ratio = 0.001obtained abs = 3.69535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 299.22 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 459.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000538019; expected ratio = 0.0001obtained abs = 7.29144e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105116; expected ratio = 0.001obtained abs = 3.62864; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 300.50 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 459.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000701484; expected ratio = 0.0001obtained abs = 9.50719e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00977212; expected ratio = 0.001obtained abs = 3.37462; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 299.86 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 456.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000816215; expected ratio = 0.0001obtained abs = 1.10632e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0101808; expected ratio = 0.001obtained abs = 3.51283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 300.50 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 459.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000893202; expected ratio = 0.0001obtained abs = 1.21075e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00906979; expected ratio = 0.001obtained abs = 3.1306; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 299.86 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 459.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000939374; expected ratio = 0.0001obtained abs = 1.27351e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.009614; expected ratio = 0.001obtained abs = 3.31551; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 299.86 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 459.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000875977; expected ratio = 0.0001obtained abs = 1.18766e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00802786; expected ratio = 0.001obtained abs = 2.76894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 299.86 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 459.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000865105; expected ratio = 0.0001obtained abs = 1.17311e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00842377; expected ratio = 0.001obtained abs = 2.9035; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 299.86 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 473.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000739358; expected ratio = 0.0001obtained abs = 1.0027e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00684423; expected ratio = 0.001obtained abs = 2.35885; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.89713 - Final Residual ratio : 0.00482126 - Residual ratio : 0.000984507 - Slope : -0.174725 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.01013 - Final Residual ratio : 0.00298725 - Residual ratio : 0.000596242 - Slope : -0.178826 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.7281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.90103 - Final Residual ratio : 0.00416808 - Residual ratio : 0.000706331 - Slope : -0.190222 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.22784 - Final Residual ratio : 0.00475701 - Residual ratio : 0.00076383 - Slope : -0.200745 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.5658 - Final Residual ratio : 0.00555648 - Residual ratio : 0.000998325 - Slope : -0.185342 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.28511 - Final Residual ratio : 0.00272657 - Residual ratio : 0.00063629 - Slope : -0.142746 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.41877 - Final Residual ratio : 0.00228212 - Residual ratio : 0.000667526 - Slope : -0.10353 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.63877 - Final Residual ratio : 0.00246568 - Residual ratio : 0.000677613 - Slope : -0.1173 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.07248 - Final Residual ratio : 0.00340858 - Residual ratio : 0.000836979 - Slope : -0.13126 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.93746 - Final Residual ratio : 0.00301178 - Residual ratio : 0.000764903 - Slope : -0.126918 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 118 - - Mesh vertices: 113 - Mesh triangles: 118 - Mesh edges: 194 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7351 -matrix_partition : [5](0,48,96,144,193) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.343330e+05 Mflops = 298.59 -Solve time = 0.00 -Solve flops = 1.468600e+04 Mflops = 443.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0649703; expected ratio = 0.0001obtained abs = 0.000894352; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.136761; expected ratio = 0.001obtained abs = 43.3338; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.360650e+05 Mflops = 302.92 -Solve time = 0.00 -Solve flops = 1.476800e+04 Mflops = 462.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0102191; expected ratio = 0.0001obtained abs = 0.000140699; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0488941; expected ratio = 0.001obtained abs = 15.8291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.367250e+05 Mflops = 303.90 -Solve time = 0.00 -Solve flops = 1.479800e+04 Mflops = 463.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00287791; expected ratio = 0.0001obtained abs = 3.95865e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0422296; expected ratio = 0.001obtained abs = 13.5755; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.367250e+05 Mflops = 303.74 -Solve time = 0.00 -Solve flops = 1.479800e+04 Mflops = 463.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000707115; expected ratio = 0.0001obtained abs = 9.72829e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0186842; expected ratio = 0.001obtained abs = 6.0123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.367250e+05 Mflops = 303.90 -Solve time = 0.00 -Solve flops = 1.479800e+04 Mflops = 477.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000422967; expected ratio = 0.0001obtained abs = 5.81823e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0110046; expected ratio = 0.001obtained abs = 3.54128; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.367250e+05 Mflops = 303.90 -Solve time = 0.00 -Solve flops = 1.479800e+04 Mflops = 463.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000200134; expected ratio = 0.0001obtained abs = 2.75293e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00930468; expected ratio = 0.001obtained abs = 2.99356; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.367250e+05 Mflops = 303.74 -Solve time = 0.00 -Solve flops = 1.479800e+04 Mflops = 463.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000143587; expected ratio = 0.0001obtained abs = 1.97502e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0085069; expected ratio = 0.001obtained abs = 2.73751; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.367250e+05 Mflops = 304.55 -Solve time = 0.00 -Solve flops = 1.479800e+04 Mflops = 463.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000103912; expected ratio = 0.0001obtained abs = 1.42926e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00771749; expected ratio = 0.001obtained abs = 2.48248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.367250e+05 Mflops = 303.74 -Solve time = 0.00 -Solve flops = 1.479800e+04 Mflops = 477.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.19356e-05; expected ratio = 0.0001obtained abs = 9.89426e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00717379; expected ratio = 0.001obtained abs = 2.30809; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.18067 - Final Residual ratio : 0.00302459 - Residual ratio : 0.000950929 - Slope : -0.105921 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.50418 - Final Residual ratio : 0.0020118 - Residual ratio : 0.000803377 - Slope : -0.0893632 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.66622 - Final Residual ratio : 0.00176817 - Residual ratio : 0.000663175 - Slope : -0.0859502 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.2222 - Final Residual ratio : 0.00258554 - Residual ratio : 0.000802417 - Slope : -0.103858 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.40856 - Final Residual ratio : 0.00273874 - Residual ratio : 0.000803489 - Slope : -0.109865 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.02081 - Final Residual ratio : 0.0019128 - Residual ratio : 0.000633206 - Slope : -0.0973839 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.33701 - Final Residual ratio : 0.00158425 - Residual ratio : 0.000677895 - Slope : -0.0778476 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.95351 - Final Residual ratio : 0.00134469 - Residual ratio : 0.000688344 - Slope : -0.0650721 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.16457 - Final Residual ratio : 0.00130321 - Residual ratio : 0.000602065 - Slope : -0.0697829 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.45179 - Final Residual ratio : 0.00137913 - Residual ratio : 0.000562502 - Slope : -0.0790454 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 9 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 117 - Mesh edges: 193 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7451 -matrix_partition : [5](0,48,96,144,193) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.322070e+05 Mflops = 299.74 -Solve time = 0.00 -Solve flops = 1.459800e+04 Mflops = 443.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0754595; expected ratio = 0.0001obtained abs = 0.00106528; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.161925; expected ratio = 0.001obtained abs = 52.5062; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.320150e+05 Mflops = 295.94 -Solve time = 0.00 -Solve flops = 1.458600e+04 Mflops = 443.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0169321; expected ratio = 0.0001obtained abs = 0.000238321; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108668; expected ratio = 0.001obtained abs = 35.3682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.320150e+05 Mflops = 299.95 -Solve time = 0.00 -Solve flops = 1.458600e+04 Mflops = 456.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0133806; expected ratio = 0.0001obtained abs = 0.000188039; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0675201; expected ratio = 0.001obtained abs = 21.851; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.320150e+05 Mflops = 300.77 -Solve time = 0.00 -Solve flops = 1.458600e+04 Mflops = 440.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0102104; expected ratio = 0.0001obtained abs = 0.000143421; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0316274; expected ratio = 0.001obtained abs = 10.2454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.320150e+05 Mflops = 300.77 -Solve time = 0.00 -Solve flops = 1.458600e+04 Mflops = 453.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00226578; expected ratio = 0.0001obtained abs = 3.18235e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0192356; expected ratio = 0.001obtained abs = 6.22458; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.320150e+05 Mflops = 299.95 -Solve time = 0.00 -Solve flops = 1.458600e+04 Mflops = 456.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000526527; expected ratio = 0.0001obtained abs = 7.39498e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0123499; expected ratio = 0.001obtained abs = 3.99809; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.320150e+05 Mflops = 300.77 -Solve time = 0.00 -Solve flops = 1.458600e+04 Mflops = 456.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000136103; expected ratio = 0.0001obtained abs = 1.91152e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00934506; expected ratio = 0.001obtained abs = 3.02533; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,117) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.320150e+05 Mflops = 301.42 -Solve time = 0.00 -Solve flops = 1.458600e+04 Mflops = 456.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.62698e-05; expected ratio = 0.0001obtained abs = 5.09397e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00725445; expected ratio = 0.001obtained abs = 2.34851; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.38027 - Final Residual ratio : 0.00131324 - Residual ratio : 0.000551721 - Slope : -0.0767405 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02788 - Final Residual ratio : 0.00124313 - Residual ratio : 0.000613018 - Slope : -0.0653753 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.72357 - Final Residual ratio : 0.00137746 - Residual ratio : 0.00079919 - Slope : -0.0615069 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7871 - Final Residual ratio : 0.00153008 - Residual ratio : 0.000856184 - Slope : -0.0595189 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 40 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02101 - Final Residual ratio : 0.00201955 - Residual ratio : 0.000999278 - Slope : -0.0672998 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.07072 - Final Residual ratio : 0.00201197 - Residual ratio : 0.000971625 - Slope : -0.0689571 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8563 - Final Residual ratio : 0.00181279 - Residual ratio : 0.000976563 - Slope : -0.0618161 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52628 - Final Residual ratio : 0.00135394 - Residual ratio : 0.000887081 - Slope : -0.0525838 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36884 - Final Residual ratio : 0.00124066 - Residual ratio : 0.000906358 - Slope : -0.0455866 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.3036 - Final Residual ratio : 0.0462832 - Residual ratio : 0.000999558 - Slope : -3.55826 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 117 - Number of Conditions : 35 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 112 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - - Mesh vertices: 112 - Mesh triangles: 167 - Mesh edges: 278 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 167 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - Input triangles: 117 - - Mesh vertices: 113 - Mesh triangles: 119 - Mesh edges: 195 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7551 -matrix_partition : [5](0,48,96,144,193) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.383780e+05 Mflops = 301.51 -Solve time = 0.00 -Solve flops = 1.498600e+04 Mflops = 455.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.063998; expected ratio = 0.0001obtained abs = 0.000912341; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.174095; expected ratio = 0.001obtained abs = 60.4369; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.369700e+05 Mflops = 301.10 -Solve time = 0.00 -Solve flops = 1.490800e+04 Mflops = 463.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0192632; expected ratio = 0.0001obtained abs = 0.000273408; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146885; expected ratio = 0.001obtained abs = 50.6895; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.363400e+05 Mflops = 300.34 -Solve time = 0.00 -Solve flops = 1.487800e+04 Mflops = 452.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00428935; expected ratio = 0.0001obtained abs = 6.09224e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0918542; expected ratio = 0.001obtained abs = 31.8636; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.363400e+05 Mflops = 298.31 -Solve time = 0.00 -Solve flops = 1.487800e+04 Mflops = 465.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00192986; expected ratio = 0.0001obtained abs = 2.74094e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0567712; expected ratio = 0.001obtained abs = 19.6081; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.363400e+05 Mflops = 300.97 -Solve time = 0.00 -Solve flops = 1.487800e+04 Mflops = 465.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00082546; expected ratio = 0.0001obtained abs = 1.17242e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0432223; expected ratio = 0.001obtained abs = 14.9453; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.354040e+05 Mflops = 299.54 -Solve time = 0.00 -Solve flops = 1.483000e+04 Mflops = 464.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000407894; expected ratio = 0.0001obtained abs = 5.79347e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0412775; expected ratio = 0.001obtained abs = 14.2712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.354040e+05 Mflops = 299.70 -Solve time = 0.00 -Solve flops = 1.483000e+04 Mflops = 460.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000205563; expected ratio = 0.0001obtained abs = 2.9197e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0394938; expected ratio = 0.001obtained abs = 13.6504; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.358480e+05 Mflops = 299.26 -Solve time = 0.00 -Solve flops = 1.485400e+04 Mflops = 461.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00011058; expected ratio = 0.0001obtained abs = 1.57062e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0383939; expected ratio = 0.001obtained abs = 13.2754; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.350200e+05 Mflops = 299.32 -Solve time = 0.00 -Solve flops = 1.480600e+04 Mflops = 463.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000136719; expected ratio = 0.0001obtained abs = 1.94188e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0401835; expected ratio = 0.001obtained abs = 13.8709; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.358480e+05 Mflops = 299.26 -Solve time = 0.00 -Solve flops = 1.485400e+04 Mflops = 461.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0011738; expected ratio = 0.0001obtained abs = 1.6672e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0399156; expected ratio = 0.001obtained abs = 13.8374; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.350200e+05 Mflops = 298.06 -Solve time = 0.00 -Solve flops = 1.480600e+04 Mflops = 463.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00123029; expected ratio = 0.0001obtained abs = 1.74767e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0376414; expected ratio = 0.001obtained abs = 12.9913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.365860e+05 Mflops = 300.88 -Solve time = 0.00 -Solve flops = 1.488400e+04 Mflops = 462.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000433331; expected ratio = 0.0001obtained abs = 6.1548e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0354625; expected ratio = 0.001obtained abs = 12.2675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.350200e+05 Mflops = 298.69 -Solve time = 0.00 -Solve flops = 1.480600e+04 Mflops = 463.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0001406; expected ratio = 0.0001obtained abs = 1.997e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0288937; expected ratio = 0.001obtained abs = 9.98256; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.365860e+05 Mflops = 300.88 -Solve time = 0.00 -Solve flops = 1.488400e+04 Mflops = 465.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000139176; expected ratio = 0.0001obtained abs = 1.97679e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0224611; expected ratio = 0.001obtained abs = 7.76485; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.350200e+05 Mflops = 298.69 -Solve time = 0.00 -Solve flops = 1.480600e+04 Mflops = 463.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00013926; expected ratio = 0.0001obtained abs = 1.97797e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0172467; expected ratio = 0.001obtained abs = 5.96078; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000451803 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.365860e+05 Mflops = 301.52 -Solve time = 0.00 -Solve flops = 1.488400e+04 Mflops = 452.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000139758; expected ratio = 0.0001obtained abs = 1.98504e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142221; expected ratio = 0.001obtained abs = 4.91711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.350200e+05 Mflops = 298.69 -Solve time = 0.00 -Solve flops = 1.480600e+04 Mflops = 463.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000139883; expected ratio = 0.0001obtained abs = 1.98682e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118885; expected ratio = 0.001obtained abs = 4.10964; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.365860e+05 Mflops = 300.88 -Solve time = 0.00 -Solve flops = 1.488400e+04 Mflops = 465.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000140069; expected ratio = 0.0001obtained abs = 1.98946e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102973; expected ratio = 0.001obtained abs = 3.55989; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.350200e+05 Mflops = 298.85 -Solve time = 0.00 -Solve flops = 1.480600e+04 Mflops = 460.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000140152; expected ratio = 0.0001obtained abs = 1.99064e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00908994; expected ratio = 0.001obtained abs = 3.14263; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,119) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.365860e+05 Mflops = 301.52 -Solve time = 0.00 -Solve flops = 1.488400e+04 Mflops = 452.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000140242; expected ratio = 0.0001obtained abs = 1.99193e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00824395; expected ratio = 0.001obtained abs = 2.84981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.0568 - Final Residual ratio : 0.0247128 - Residual ratio : 0.000747586 - Slope : -1.83512 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 45.2481 - Final Residual ratio : 0.0431617 - Residual ratio : 0.00095389 - Slope : -1.45822 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7581 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.5688 - Final Residual ratio : 0.0228077 - Residual ratio : 0.000746109 - Slope : -1.09093 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.0931 - Final Residual ratio : 0.0203013 - Residual ratio : 0.000809039 - Slope : -0.895458 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.2136 - Final Residual ratio : 0.0414568 - Residual ratio : 0.000859856 - Slope : -1.85278 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.7423 - Final Residual ratio : 0.0144731 - Residual ratio : 0.00081574 - Slope : -0.886391 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.2279 - Final Residual ratio : 0.0110746 - Residual ratio : 0.000837217 - Slope : -0.455751 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8514 - Final Residual ratio : 0.00853623 - Residual ratio : 0.000664226 - Slope : -0.442857 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.3754 - Final Residual ratio : 0.00851769 - Residual ratio : 0.000688278 - Slope : -0.426443 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.8546 - Final Residual ratio : 0.00589505 - Residual ratio : 0.000543091 - Slope : -0.374095 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 119 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 111 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 111 - - Mesh vertices: 111 - Mesh triangles: 165 - Mesh edges: 275 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 165 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 111 - Input triangles: 115 - - Mesh vertices: 111 - Mesh triangles: 115 - Mesh edges: 189 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7651 -matrix_partition : [5](0,46,92,138,187) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.313140e+05 Mflops = 299.66 -Solve time = 0.00 -Solve flops = 1.431200e+04 Mflops = 447.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0633001; expected ratio = 0.0001obtained abs = 0.000910098; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172679; expected ratio = 0.001obtained abs = 61.6164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000436783 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331320e+05 Mflops = 302.00 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0158438; expected ratio = 0.0001obtained abs = 0.000228791; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0667578; expected ratio = 0.001obtained abs = 24.1137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.344220e+05 Mflops = 294.26 -Solve time = 0.00 -Solve flops = 1.446200e+04 Mflops = 463.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00883964; expected ratio = 0.0001obtained abs = 0.000127566; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0458979; expected ratio = 0.001obtained abs = 16.714; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331540e+05 Mflops = 303.36 -Solve time = 0.00 -Solve flops = 1.440400e+04 Mflops = 464.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0059089; expected ratio = 0.0001obtained abs = 8.53061e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0379977; expected ratio = 0.001obtained abs = 13.7158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331320e+05 Mflops = 303.31 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00434128; expected ratio = 0.0001obtained abs = 6.26507e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0306055; expected ratio = 0.001obtained abs = 11.0895; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331320e+05 Mflops = 302.49 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00376225; expected ratio = 0.0001obtained abs = 5.43023e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0262328; expected ratio = 0.001obtained abs = 9.48332; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.00043416 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.344220e+05 Mflops = 302.15 -Solve time = 0.00 -Solve flops = 1.446200e+04 Mflops = 466.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00321751; expected ratio = 0.0001obtained abs = 4.64318e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0179041; expected ratio = 0.001obtained abs = 6.47976; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331540e+05 Mflops = 303.36 -Solve time = 0.00 -Solve flops = 1.440400e+04 Mflops = 464.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00224256; expected ratio = 0.0001obtained abs = 3.23685e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0128739; expected ratio = 0.001obtained abs = 4.65072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331320e+05 Mflops = 303.31 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00144968; expected ratio = 0.0001obtained abs = 2.09205e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00954858; expected ratio = 0.001obtained abs = 3.45247; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331320e+05 Mflops = 303.31 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000730962; expected ratio = 0.0001obtained abs = 1.05493e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00760084; expected ratio = 0.001obtained abs = 2.74556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331320e+05 Mflops = 302.65 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000452564; expected ratio = 0.0001obtained abs = 6.53103e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00550814; expected ratio = 0.001obtained abs = 1.99042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331320e+05 Mflops = 303.31 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000237795; expected ratio = 0.0001obtained abs = 3.43174e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00399882; expected ratio = 0.001obtained abs = 1.44471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331320e+05 Mflops = 303.15 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00013497; expected ratio = 0.0001obtained abs = 1.94779e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00292604; expected ratio = 0.001obtained abs = 1.05725; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.331320e+05 Mflops = 303.31 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 450.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.45559e-05; expected ratio = 0.0001obtained abs = 1.07595e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0021606; expected ratio = 0.001obtained abs = 0.780631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.867 - Final Residual ratio : 0.00609839 - Residual ratio : 0.000410196 - Slope : -0.450331 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.073 - Final Residual ratio : 0.0198265 - Residual ratio : 0.00098772 - Slope : -0.716184 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.4517 - Final Residual ratio : 0.0127839 - Residual ratio : 0.000625077 - Slope : -0.704792 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.4466 - Final Residual ratio : 0.0119389 - Residual ratio : 0.000684311 - Slope : -0.581157 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.3834 - Final Residual ratio : 0.0133584 - Residual ratio : 0.000998136 - Slope : -0.703685 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7711 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.90228 - Final Residual ratio : 0.00861411 - Residual ratio : 0.000869912 - Slope : -0.353345 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.96549 - Final Residual ratio : 0.00445753 - Residual ratio : 0.000559605 - Slope : -0.284323 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.29633 - Final Residual ratio : 0.00427847 - Residual ratio : 0.000586387 - Slope : -0.243068 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.87206 - Final Residual ratio : 0.00513306 - Residual ratio : 0.000746946 - Slope : -0.214591 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7751 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.17313 - Final Residual ratio : 0.00460483 - Residual ratio : 0.000745947 - Slope : -0.205618 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 14 - - Mesh 0 : - Number of Nodes : 111 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 111 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 111 - - Mesh vertices: 111 - Mesh triangles: 165 - Mesh edges: 275 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 165 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 111 - Input triangles: 115 - - Mesh vertices: 111 - Mesh triangles: 115 - Mesh edges: 189 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7751 -matrix_partition : [5](0,46,92,138,187) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.341760e+05 Mflops = 297.45 -Solve time = 0.00 -Solve flops = 1.447600e+04 Mflops = 453.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.056463; expected ratio = 0.0001obtained abs = 0.000828034; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.318745; expected ratio = 0.001obtained abs = 100.514; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.341760e+05 Mflops = 297.45 -Solve time = 0.00 -Solve flops = 1.447600e+04 Mflops = 467.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0131267; expected ratio = 0.0001obtained abs = 0.000191584; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.115319; expected ratio = 0.001obtained abs = 36.7581; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.341760e+05 Mflops = 298.87 -Solve time = 0.00 -Solve flops = 1.447600e+04 Mflops = 453.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0031656; expected ratio = 0.0001obtained abs = 4.62327e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0896002; expected ratio = 0.001obtained abs = 28.9955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.342360e+05 Mflops = 298.85 -Solve time = 0.00 -Solve flops = 1.448000e+04 Mflops = 453.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0012941; expected ratio = 0.0001obtained abs = 1.88984e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106099; expected ratio = 0.001obtained abs = 33.5801; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.341760e+05 Mflops = 298.24 -Solve time = 0.00 -Solve flops = 1.447600e+04 Mflops = 453.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00051671; expected ratio = 0.0001obtained abs = 7.54604e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0640768; expected ratio = 0.001obtained abs = 20.288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.341760e+05 Mflops = 298.08 -Solve time = 0.00 -Solve flops = 1.447600e+04 Mflops = 453.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000216737; expected ratio = 0.0001obtained abs = 3.16528e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0522408; expected ratio = 0.001obtained abs = 16.6585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.341760e+05 Mflops = 298.24 -Solve time = 0.00 -Solve flops = 1.447600e+04 Mflops = 453.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.33946e-05; expected ratio = 0.0001obtained abs = 1.36395e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0304437; expected ratio = 0.001obtained abs = 9.63079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.30298 - Final Residual ratio : 0.00373488 - Residual ratio : 0.000704298 - Slope : -0.176641 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.61 - Final Residual ratio : 0.00361399 - Residual ratio : 0.000783945 - Slope : -0.170607 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.25159 - Final Residual ratio : 0.00303616 - Residual ratio : 0.000714124 - Slope : -0.141619 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.10802 - Final Residual ratio : 0.00283652 - Residual ratio : 0.000690483 - Slope : -0.141558 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.02448 - Final Residual ratio : 0.00303746 - Residual ratio : 0.000754746 - Slope : -0.154671 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.95919 - Final Residual ratio : 0.00281214 - Residual ratio : 0.000710282 - Slope : -0.123637 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.89816 - Final Residual ratio : 0.00305978 - Residual ratio : 0.000784928 - Slope : -0.129837 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79065 - Final Residual ratio : 0.00269821 - Residual ratio : 0.000711805 - Slope : -0.145691 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.597 - Final Residual ratio : 0.00275277 - Residual ratio : 0.000765295 - Slope : -0.119808 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36692 - Final Residual ratio : 0.00263743 - Residual ratio : 0.000783336 - Slope : -0.11601 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 111 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 111 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 111 - - Mesh vertices: 111 - Mesh triangles: 165 - Mesh edges: 275 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 165 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 111 - Input triangles: 115 - - Mesh vertices: 111 - Mesh triangles: 115 - Mesh edges: 189 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7851 -matrix_partition : [5](0,46,92,138,187) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.370930e+05 Mflops = 306.67 -Solve time = 0.00 -Solve flops = 1.462000e+04 Mflops = 457.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0453744; expected ratio = 0.0001obtained abs = 0.000670707; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.22672; expected ratio = 0.001obtained abs = 81.928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.352030e+05 Mflops = 306.03 -Solve time = 0.00 -Solve flops = 1.453000e+04 Mflops = 468.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00670578; expected ratio = 0.0001obtained abs = 9.92063e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0526947; expected ratio = 0.001obtained abs = 19.2761; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.370490e+05 Mflops = 310.05 -Solve time = 0.00 -Solve flops = 1.463600e+04 Mflops = 458.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00343287; expected ratio = 0.0001obtained abs = 5.0748e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0349162; expected ratio = 0.001obtained abs = 12.7506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.370490e+05 Mflops = 308.05 -Solve time = 0.00 -Solve flops = 1.463600e+04 Mflops = 472.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00119823; expected ratio = 0.0001obtained abs = 1.77151e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0213766; expected ratio = 0.001obtained abs = 7.82411; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.370490e+05 Mflops = 309.38 -Solve time = 0.00 -Solve flops = 1.463600e+04 Mflops = 472.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000629479; expected ratio = 0.0001obtained abs = 9.30626e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0226473; expected ratio = 0.001obtained abs = 8.27493; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000488997 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.370490e+05 Mflops = 307.89 -Solve time = 0.00 -Solve flops = 1.463600e+04 Mflops = 472.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000352163; expected ratio = 0.0001obtained abs = 5.20635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0457302; expected ratio = 0.001obtained abs = 16.7325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.370490e+05 Mflops = 308.71 -Solve time = 0.00 -Solve flops = 1.463600e+04 Mflops = 458.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000247358; expected ratio = 0.0001obtained abs = 3.65691e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0435644; expected ratio = 0.001obtained abs = 15.917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.370490e+05 Mflops = 308.05 -Solve time = 0.00 -Solve flops = 1.463600e+04 Mflops = 458.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000166089; expected ratio = 0.0001obtained abs = 2.45544e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0342124; expected ratio = 0.001obtained abs = 12.5243; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.370490e+05 Mflops = 309.38 -Solve time = 0.00 -Solve flops = 1.463600e+04 Mflops = 472.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000109573; expected ratio = 0.0001obtained abs = 1.61991e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0249956; expected ratio = 0.001obtained abs = 9.13933; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000485182 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.370490e+05 Mflops = 307.89 -Solve time = 0.00 -Solve flops = 1.463600e+04 Mflops = 472.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.21763e-05; expected ratio = 0.0001obtained abs = 1.21488e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0156351; expected ratio = 0.001obtained abs = 5.71752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.20338 - Final Residual ratio : 0.00293845 - Residual ratio : 0.000917298 - Slope : -0.168444 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 58.4057 - Final Residual ratio : 0.0544327 - Residual ratio : 0.000931976 - Slope : -3.24174 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.0083 - Final Residual ratio : 0.0306566 - Residual ratio : 0.000806576 - Slope : -1.80846 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.3357 - Final Residual ratio : 0.0383131 - Residual ratio : 0.000904982 - Slope : -1.62682 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.296 - Final Residual ratio : 0.0279208 - Residual ratio : 0.000986741 - Slope : -1.17784 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.9641 - Final Residual ratio : 0.0183132 - Residual ratio : 0.000797472 - Slope : -1.27477 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.6271 - Final Residual ratio : 0.0162886 - Residual ratio : 0.000924064 - Slope : -0.60727 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.1275 - Final Residual ratio : 0.0122073 - Residual ratio : 0.0009299 - Slope : -0.452252 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.019 - Final Residual ratio : 0.00821631 - Residual ratio : 0.000820076 - Slope : -0.345198 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.14018 - Final Residual ratio : 0.00609381 - Residual ratio : 0.000748608 - Slope : -0.290503 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.7951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 111 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 111 - - Mesh vertices: 110 - Mesh triangles: 113 - Mesh edges: 186 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.7951 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.363250e+05 Mflops = 301.58 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 450.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0508191; expected ratio = 0.0001obtained abs = 0.000745928; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.302509; expected ratio = 0.001obtained abs = 90.2297; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.385330e+05 Mflops = 305.17 -Solve time = 0.00 -Solve flops = 1.449600e+04 Mflops = 467.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0138912; expected ratio = 0.0001obtained abs = 0.000203468; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121541; expected ratio = 0.001obtained abs = 37.5834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.392650e+05 Mflops = 304.71 -Solve time = 0.00 -Solve flops = 1.454000e+04 Mflops = 469.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00203318; expected ratio = 0.0001obtained abs = 2.97999e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.115901; expected ratio = 0.001obtained abs = 35.4495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.385330e+05 Mflops = 304.37 -Solve time = 0.00 -Solve flops = 1.449600e+04 Mflops = 467.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000311039; expected ratio = 0.0001obtained abs = 4.55847e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0899392; expected ratio = 0.001obtained abs = 28.2583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.385330e+05 Mflops = 304.37 -Solve time = 0.00 -Solve flops = 1.449600e+04 Mflops = 467.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.34174e-05; expected ratio = 0.0001obtained abs = 9.29427e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0821434; expected ratio = 0.001obtained abs = 25.3065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.7961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.07664 - Final Residual ratio : 0.00575386 - Residual ratio : 0.000813077 - Slope : -0.29462 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.42586 - Final Residual ratio : 0.00600135 - Residual ratio : 0.000933938 - Slope : -0.246918 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.93623 - Final Residual ratio : 0.00459295 - Residual ratio : 0.000773714 - Slope : -0.211844 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.7991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.49597 - Final Residual ratio : 0.00418222 - Residual ratio : 0.000760961 - Slope : -0.196135 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.7991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.08879 - Final Residual ratio : 0.00440005 - Residual ratio : 0.000864657 - Slope : -0.181585 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.80546 - Final Residual ratio : 0.00470888 - Residual ratio : 0.000979903 - Slope : -0.177805 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.64621 - Final Residual ratio : 0.00375945 - Residual ratio : 0.000809143 - Slope : -0.178556 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.4162 - Final Residual ratio : 0.00911195 - Residual ratio : 0.000967688 - Slope : -0.447957 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.3545 - Final Residual ratio : 0.020804 - Residual ratio : 0.00097422 - Slope : -1.52384 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.6407 - Final Residual ratio : 0.00540401 - Residual ratio : 0.000813771 - Slope : -0.236975 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 113 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 113 - - Mesh vertices: 110 - Mesh triangles: 113 - Mesh edges: 186 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8051 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000418186 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.395500e+05 Mflops = 305.97 -Solve time = 0.00 -Solve flops = 1.453400e+04 Mflops = 454.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0523607; expected ratio = 0.0001obtained abs = 0.000778193; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.234178; expected ratio = 0.001obtained abs = 84.47; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.355960e+05 Mflops = 303.32 -Solve time = 0.00 -Solve flops = 1.435600e+04 Mflops = 463.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00667408; expected ratio = 0.0001obtained abs = 9.90492e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172784; expected ratio = 0.001obtained abs = 67.251; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.362560e+05 Mflops = 304.80 -Solve time = 0.00 -Solve flops = 1.438600e+04 Mflops = 464.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00216323; expected ratio = 0.0001obtained abs = 3.21073e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.225723; expected ratio = 0.001obtained abs = 82.3448; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.372880e+05 Mflops = 305.80 -Solve time = 0.00 -Solve flops = 1.445000e+04 Mflops = 466.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000954438; expected ratio = 0.0001obtained abs = 1.41658e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16279; expected ratio = 0.001obtained abs = 57.9291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.369460e+05 Mflops = 307.00 -Solve time = 0.00 -Solve flops = 1.442000e+04 Mflops = 465.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000448045; expected ratio = 0.0001obtained abs = 6.6499e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0836154; expected ratio = 0.001obtained abs = 30.0078; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.370060e+05 Mflops = 307.30 -Solve time = 0.00 -Solve flops = 1.442400e+04 Mflops = 465.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000306055; expected ratio = 0.0001obtained abs = 4.54249e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0590885; expected ratio = 0.001obtained abs = 21.0112; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.364960e+05 Mflops = 306.81 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000173821; expected ratio = 0.0001obtained abs = 2.57988e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0425717; expected ratio = 0.001obtained abs = 15.3084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000407219 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.369460e+05 Mflops = 307.66 -Solve time = 0.00 -Solve flops = 1.442000e+04 Mflops = 465.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000130426; expected ratio = 0.0001obtained abs = 1.93579e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0273835; expected ratio = 0.001obtained abs = 9.81923; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.369460e+05 Mflops = 307.82 -Solve time = 0.00 -Solve flops = 1.442000e+04 Mflops = 465.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.54584e-05; expected ratio = 0.0001obtained abs = 1.4168e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.022027; expected ratio = 0.001obtained abs = 7.87151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.2777 - Final Residual ratio : 0.0187459 - Residual ratio : 0.000841465 - Slope : -2.02354 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4717 - Final Residual ratio : 0.0129886 - Residual ratio : 0.000964145 - Slope : -0.791687 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.0309 - Final Residual ratio : 0.0125147 - Residual ratio : 0.00089194 - Slope : -0.539168 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8058 - Final Residual ratio : 0.012388 - Residual ratio : 0.000967373 - Slope : -0.492056 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.2933 - Final Residual ratio : 0.00809951 - Residual ratio : 0.000717194 - Slope : -0.417971 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1281 - Final Residual ratio : 0.00799562 - Residual ratio : 0.000789451 - Slope : -0.374818 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.17311 - Final Residual ratio : 0.0068275 - Residual ratio : 0.000744295 - Slope : -0.339492 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.43317 - Final Residual ratio : 0.00770528 - Residual ratio : 0.000913687 - Slope : -0.324056 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.69138 - Final Residual ratio : 0.00791785 - Residual ratio : 0.000816999 - Slope : -0.645564 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.0274 - Final Residual ratio : 0.0175409 - Residual ratio : 0.000834194 - Slope : -0.750352 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 9 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 113 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 113 - - Mesh vertices: 110 - Mesh triangles: 113 - Mesh edges: 186 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8151 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.374450e+05 Mflops = 303.41 -Solve time = 0.00 -Solve flops = 1.450000e+04 Mflops = 467.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0432151; expected ratio = 0.0001obtained abs = 0.000647928; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.115412; expected ratio = 0.001obtained abs = 38.2169; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.408890e+05 Mflops = 311.84 -Solve time = 0.00 -Solve flops = 1.463800e+04 Mflops = 472.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00335128; expected ratio = 0.0001obtained abs = 5.02047e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0717814; expected ratio = 0.001obtained abs = 24.2927; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.374450e+05 Mflops = 305.99 -Solve time = 0.00 -Solve flops = 1.450000e+04 Mflops = 467.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000853814; expected ratio = 0.0001obtained abs = 1.27916e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0617332; expected ratio = 0.001obtained abs = 20.7102; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.374450e+05 Mflops = 305.99 -Solve time = 0.00 -Solve flops = 1.450000e+04 Mflops = 467.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000106402; expected ratio = 0.0001obtained abs = 1.59406e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0468725; expected ratio = 0.001obtained abs = 15.8221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.374450e+05 Mflops = 305.50 -Solve time = 0.00 -Solve flops = 1.450000e+04 Mflops = 467.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.85701e-05; expected ratio = 0.0001obtained abs = 4.28025e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0332051; expected ratio = 0.001obtained abs = 11.1602; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.88519 - Final Residual ratio : 0.00893609 - Residual ratio : 0.000903987 - Slope : -0.658417 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.2544 - Final Residual ratio : 0.00619224 - Residual ratio : 0.000853583 - Slope : -0.249938 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.6062 - Final Residual ratio : 0.00578082 - Residual ratio : 0.000875059 - Slope : -0.227601 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.13403 - Final Residual ratio : 0.00419054 - Residual ratio : 0.000683162 - Slope : -0.211374 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.61177 - Final Residual ratio : 0.00430267 - Residual ratio : 0.000766722 - Slope : -0.200267 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8211 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.09419 - Final Residual ratio : 0.00431428 - Residual ratio : 0.000846902 - Slope : -0.181781 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.60571 - Final Residual ratio : 0.00334033 - Residual ratio : 0.000725258 - Slope : -0.16437 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.22459 - Final Residual ratio : 0.00313148 - Residual ratio : 0.000741249 - Slope : -0.15635 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.95831 - Final Residual ratio : 0.00325854 - Residual ratio : 0.000823215 - Slope : -0.146483 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.77726 - Final Residual ratio : 0.00310415 - Residual ratio : 0.000821802 - Slope : -0.25161 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 113 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 111 - - Mesh vertices: 110 - Mesh triangles: 113 - Mesh edges: 186 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8251 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.395200e+05 Mflops = 303.36 -Solve time = 0.00 -Solve flops = 1.462600e+04 Mflops = 454.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0411972; expected ratio = 0.0001obtained abs = 0.00062131; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0645066; expected ratio = 0.001obtained abs = 22.3697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.390700e+05 Mflops = 311.76 -Solve time = 0.00 -Solve flops = 1.460800e+04 Mflops = 457.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00543648; expected ratio = 0.0001obtained abs = 8.18871e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0205267; expected ratio = 0.001obtained abs = 7.15981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000408173 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.390700e+05 Mflops = 307.81 -Solve time = 0.00 -Solve flops = 1.460800e+04 Mflops = 471.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00233538; expected ratio = 0.0001obtained abs = 3.51777e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0125338; expected ratio = 0.001obtained abs = 4.36851; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.390700e+05 Mflops = 311.76 -Solve time = 0.00 -Solve flops = 1.460800e+04 Mflops = 471.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00115626; expected ratio = 0.0001obtained abs = 1.74165e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00802432; expected ratio = 0.001obtained abs = 2.79572; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.390700e+05 Mflops = 312.43 -Solve time = 0.00 -Solve flops = 1.460800e+04 Mflops = 457.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000639191; expected ratio = 0.0001obtained abs = 9.62784e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0045793; expected ratio = 0.001obtained abs = 1.5955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.389140e+05 Mflops = 312.08 -Solve time = 0.00 -Solve flops = 1.460200e+04 Mflops = 471.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000376979; expected ratio = 0.0001obtained abs = 5.67821e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0031834; expected ratio = 0.001obtained abs = 1.10875; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.389140e+05 Mflops = 312.24 -Solve time = 0.00 -Solve flops = 1.460200e+04 Mflops = 457.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000230843; expected ratio = 0.0001obtained abs = 3.47704e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00191158; expected ratio = 0.001obtained abs = 0.665849; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.389140e+05 Mflops = 312.24 -Solve time = 0.00 -Solve flops = 1.460200e+04 Mflops = 471.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000144807; expected ratio = 0.0001obtained abs = 2.18113e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00138604; expected ratio = 0.001obtained abs = 0.482713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.389140e+05 Mflops = 303.30 -Solve time = 0.00 -Solve flops = 1.460200e+04 Mflops = 471.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.16682e-05; expected ratio = 0.0001obtained abs = 1.38073e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000825254; expected ratio = 0.001obtained abs = 0.287421; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.61167 - Final Residual ratio : 0.00271253 - Residual ratio : 0.000751046 - Slope : -0.240597 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8271 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.43878 - Final Residual ratio : 0.00322526 - Residual ratio : 0.000937908 - Slope : -0.245397 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.25577 - Final Residual ratio : 0.00268818 - Residual ratio : 0.000825667 - Slope : -0.116181 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.8291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.06531 - Final Residual ratio : 0.00291097 - Residual ratio : 0.000949649 - Slope : -0.109371 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.92143 - Final Residual ratio : 0.00279832 - Residual ratio : 0.000957858 - Slope : -0.104237 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.74438 - Final Residual ratio : 0.00234817 - Residual ratio : 0.000855628 - Slope : -0.101557 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.61137 - Final Residual ratio : 0.00212678 - Residual ratio : 0.00081443 - Slope : -0.0966386 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5143 - Final Residual ratio : 0.0111112 - Residual ratio : 0.000964996 - Slope : -0.44243 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.2188 - Final Residual ratio : 0.0199224 - Residual ratio : 0.000938902 - Slope : -0.815341 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.783 - Final Residual ratio : 0.0199418 - Residual ratio : 0.000838487 - Slope : -0.913965 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 9 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 113 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 109 - - Mesh vertices: 108 - Mesh triangles: 109 - Mesh edges: 180 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8351 -matrix_partition : [5](0,44,88,132,178) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.346220e+05 Mflops = 303.90 -Solve time = 0.00 -Solve flops = 1.408400e+04 Mflops = 468.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0413106; expected ratio = 0.0001obtained abs = 0.000594437; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0809951; expected ratio = 0.001obtained abs = 27.4496; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000394106 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.375260e+05 Mflops = 308.46 -Solve time = 0.00 -Solve flops = 1.420400e+04 Mflops = 454.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0098406; expected ratio = 0.0001obtained abs = 0.000141686; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0656012; expected ratio = 0.001obtained abs = 22.705; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000393867 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.375260e+05 Mflops = 307.64 -Solve time = 0.00 -Solve flops = 1.420400e+04 Mflops = 472.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00138089; expected ratio = 0.0001obtained abs = 1.98792e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0453977; expected ratio = 0.001obtained abs = 15.6344; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000400066 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.375260e+05 Mflops = 308.46 -Solve time = 0.00 -Solve flops = 1.420400e+04 Mflops = 458.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000119877; expected ratio = 0.0001obtained abs = 1.72574e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0285336; expected ratio = 0.001obtained abs = 9.86161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.371660e+05 Mflops = 306.84 -Solve time = 0.00 -Solve flops = 1.418600e+04 Mflops = 472.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.09019e-05; expected ratio = 0.0001obtained abs = 1.0207e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0177407; expected ratio = 0.001obtained abs = 6.11771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.15225 - Final Residual ratio : 0.00706319 - Residual ratio : 0.00086641 - Slope : -0.290899 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5744 - Final Residual ratio : 0.0134446 - Residual ratio : 0.000811169 - Slope : -0.591462 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.6999 - Final Residual ratio : 0.0126367 - Residual ratio : 0.000713942 - Slope : -0.631688 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.3925 - Final Residual ratio : 0.0111393 - Residual ratio : 0.000723686 - Slope : -0.56968 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.1212 - Final Residual ratio : 0.00906619 - Residual ratio : 0.000747961 - Slope : -0.403738 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.31101 - Final Residual ratio : 0.00670747 - Residual ratio : 0.000720381 - Slope : -0.320838 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.64507 - Final Residual ratio : 0.00722335 - Residual ratio : 0.000944837 - Slope : -0.263374 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.84787 - Final Residual ratio : 0.00341491 - Residual ratio : 0.000498682 - Slope : -0.236016 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.30296 - Final Residual ratio : 0.00559585 - Residual ratio : 0.000887814 - Slope : -0.233236 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.80726 - Final Residual ratio : 0.00408615 - Residual ratio : 0.000703628 - Slope : -0.207256 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 109 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 109 - - Mesh vertices: 108 - Mesh triangles: 109 - Mesh edges: 180 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8451 -matrix_partition : [5](0,44,88,132,178) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.354660e+05 Mflops = 303.68 -Solve time = 0.00 -Solve flops = 1.408000e+04 Mflops = 454.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0423639; expected ratio = 0.0001obtained abs = 0.000613086; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0254401; expected ratio = 0.001obtained abs = 8.7648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000394821 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.334980e+05 Mflops = 304.81 -Solve time = 0.00 -Solve flops = 1.400200e+04 Mflops = 451.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00388489; expected ratio = 0.0001obtained abs = 5.61971e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0179394; expected ratio = 0.001obtained abs = 6.24175; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000391006 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.329220e+05 Mflops = 304.15 -Solve time = 0.00 -Solve flops = 1.397800e+04 Mflops = 469.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00170943; expected ratio = 0.0001obtained abs = 2.47283e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00701647; expected ratio = 0.001obtained abs = 2.43965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000392914 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.329220e+05 Mflops = 299.42 -Solve time = 0.00 -Solve flops = 1.397800e+04 Mflops = 450.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000152; expected ratio = 0.0001obtained abs = 2.19877e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00367425; expected ratio = 0.001obtained abs = 1.27799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000392914 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.329220e+05 Mflops = 303.49 -Solve time = 0.00 -Solve flops = 1.397800e+04 Mflops = 465.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.4753e-05; expected ratio = 0.0001obtained abs = 3.58068e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.002128; expected ratio = 0.001obtained abs = 0.740133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.26645 - Final Residual ratio : 0.00374833 - Residual ratio : 0.000711738 - Slope : -0.181472 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.86009 - Final Residual ratio : 0.00318131 - Residual ratio : 0.000654578 - Slope : -0.167479 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.39883 - Final Residual ratio : 0.00339012 - Residual ratio : 0.000770688 - Slope : -0.151567 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.75784 - Final Residual ratio : 0.00162891 - Residual ratio : 0.000433471 - Slope : -0.129524 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8501 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11771 - Final Residual ratio : 0.00303605 - Residual ratio : 0.000973808 - Slope : -0.119795 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.66944 - Final Residual ratio : 0.00206829 - Residual ratio : 0.000774803 - Slope : -0.0889125 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.7469 - Final Residual ratio : 0.00176403 - Residual ratio : 0.00064219 - Slope : -0.0946599 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.95452 - Final Residual ratio : 0.00258067 - Residual ratio : 0.000873464 - Slope : -0.105426 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.94083 - Final Residual ratio : 0.00243472 - Residual ratio : 0.000827902 - Slope : -0.101324 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.76637 - Final Residual ratio : 0.00250323 - Residual ratio : 0.000904876 - Slope : -0.0953059 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 109 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 108 - - Mesh vertices: 108 - Mesh triangles: 108 - Mesh edges: 178 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8551 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000398159 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.264600e+05 Mflops = 298.32 -Solve time = 0.00 -Solve flops = 1.367200e+04 Mflops = 455.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0385919; expected ratio = 0.0001obtained abs = 0.000559617; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0619336; expected ratio = 0.001obtained abs = 20.7717; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390053 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.305280e+05 Mflops = 307.92 -Solve time = 0.00 -Solve flops = 1.384000e+04 Mflops = 460.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00300251; expected ratio = 0.0001obtained abs = 4.35468e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0360116; expected ratio = 0.001obtained abs = 12.2264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390053 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.305280e+05 Mflops = 307.92 -Solve time = 0.00 -Solve flops = 1.384000e+04 Mflops = 460.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000322678; expected ratio = 0.0001obtained abs = 4.67988e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0210748; expected ratio = 0.001obtained abs = 7.14033; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390053 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.305280e+05 Mflops = 308.61 -Solve time = 0.00 -Solve flops = 1.384000e+04 Mflops = 460.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.38034e-05; expected ratio = 0.0001obtained abs = 6.35288e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0121915; expected ratio = 0.001obtained abs = 4.13558; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.65909 - Final Residual ratio : 0.00218755 - Residual ratio : 0.000822667 - Slope : -0.098404 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.21454 - Final Residual ratio : 0.00291372 - Residual ratio : 0.00090642 - Slope : -0.229402 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.67612 - Final Residual ratio : 0.0028295 - Residual ratio : 0.000769698 - Slope : -0.131189 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.81285 - Final Residual ratio : 0.00378016 - Residual ratio : 0.000991427 - Slope : -0.141077 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.08957 - Final Residual ratio : 0.00336472 - Residual ratio : 0.000822756 - Slope : -0.145936 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8611 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.46259 - Final Residual ratio : 0.00296063 - Residual ratio : 0.000663432 - Slope : -0.159273 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.3867 - Final Residual ratio : 0.00373922 - Residual ratio : 0.0008524 - Slope : -0.156534 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8631 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.1656 - Final Residual ratio : 0.00261684 - Residual ratio : 0.000628203 - Slope : -0.143551 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.9472 - Final Residual ratio : 0.00253412 - Residual ratio : 0.000642004 - Slope : -0.136023 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79849 - Final Residual ratio : 0.0026495 - Residual ratio : 0.000697515 - Slope : -0.130891 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 108 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 108 - - Mesh vertices: 108 - Mesh triangles: 108 - Mesh edges: 178 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8651 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000399113 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.289520e+05 Mflops = 305.57 -Solve time = 0.00 -Solve flops = 1.373200e+04 Mflops = 457.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0381008; expected ratio = 0.0001obtained abs = 0.000552545; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0435045; expected ratio = 0.001obtained abs = 14.9549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000389814 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.248840e+05 Mflops = 299.49 -Solve time = 0.00 -Solve flops = 1.356400e+04 Mflops = 451.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00252222; expected ratio = 0.0001obtained abs = 3.65865e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136735; expected ratio = 0.001obtained abs = 4.75448; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000393152 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.248840e+05 Mflops = 299.32 -Solve time = 0.00 -Solve flops = 1.356400e+04 Mflops = 455.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00155207; expected ratio = 0.0001obtained abs = 2.25124e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00865831; expected ratio = 0.001obtained abs = 3.007; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390053 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.248840e+05 Mflops = 298.80 -Solve time = 0.00 -Solve flops = 1.356400e+04 Mflops = 451.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.52223e-05; expected ratio = 0.0001obtained abs = 9.46032e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00495673; expected ratio = 0.001obtained abs = 1.72199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.57091 - Final Residual ratio : 0.00331856 - Residual ratio : 0.000929333 - Slope : -0.132133 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8671 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.41898 - Final Residual ratio : 0.00336584 - Residual ratio : 0.000984458 - Slope : -0.110181 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.29733 - Final Residual ratio : 0.00192555 - Residual ratio : 0.000583972 - Slope : -0.113635 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.18935 - Final Residual ratio : 0.0027474 - Residual ratio : 0.000861429 - Slope : -0.113807 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11421 - Final Residual ratio : 0.00274395 - Residual ratio : 0.000881105 - Slope : -0.124459 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.96518 - Final Residual ratio : 0.00294414 - Residual ratio : 0.000992902 - Slope : -0.105794 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.88895 - Final Residual ratio : 0.002334 - Residual ratio : 0.000807906 - Slope : -0.103094 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.8448 - Final Residual ratio : 0.00183756 - Residual ratio : 0.000645936 - Slope : -0.0980333 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.80722 - Final Residual ratio : 0.00152192 - Residual ratio : 0.000542145 - Slope : -0.0967482 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.8002 - Final Residual ratio : 0.00269732 - Residual ratio : 0.000963258 - Slope : -0.099911 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 108 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 108 - - Mesh vertices: 108 - Mesh triangles: 108 - Mesh edges: 178 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8751 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000398159 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.258620e+05 Mflops = 295.41 -Solve time = 0.00 -Solve flops = 1.358200e+04 Mflops = 452.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0423988; expected ratio = 0.0001obtained abs = 0.000614239; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0596662; expected ratio = 0.001obtained abs = 20.802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390768 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.264800e+05 Mflops = 296.86 -Solve time = 0.00 -Solve flops = 1.360600e+04 Mflops = 471.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00728208; expected ratio = 0.0001obtained abs = 0.000105574; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0313274; expected ratio = 0.001obtained abs = 11.1492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000389814 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.269180e+05 Mflops = 299.40 -Solve time = 0.00 -Solve flops = 1.362400e+04 Mflops = 468.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00442385; expected ratio = 0.0001obtained abs = 6.41317e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0104809; expected ratio = 0.001obtained abs = 3.72158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390053 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.267800e+05 Mflops = 298.24 -Solve time = 0.00 -Solve flops = 1.361800e+04 Mflops = 453.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00162587; expected ratio = 0.0001obtained abs = 2.35695e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187415; expected ratio = 0.001obtained abs = 6.65632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000387907 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.267800e+05 Mflops = 294.27 -Solve time = 0.00 -Solve flops = 1.361800e+04 Mflops = 453.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000661115; expected ratio = 0.0001obtained abs = 9.58385e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0426024; expected ratio = 0.001obtained abs = 15.0938; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390053 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.258320e+05 Mflops = 296.84 -Solve time = 0.00 -Solve flops = 1.357600e+04 Mflops = 451.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000440646; expected ratio = 0.0001obtained abs = 6.38783e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0239765; expected ratio = 0.001obtained abs = 8.49495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000391006 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.258320e+05 Mflops = 298.18 -Solve time = 0.00 -Solve flops = 1.357600e+04 Mflops = 470.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000249491; expected ratio = 0.0001obtained abs = 3.61674e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0132082; expected ratio = 0.001obtained abs = 4.67986; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000396013 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.258320e+05 Mflops = 289.99 -Solve time = 0.00 -Solve flops = 1.357600e+04 Mflops = 451.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000169803; expected ratio = 0.0001obtained abs = 2.46154e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00927264; expected ratio = 0.001obtained abs = 3.28408; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390053 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.258320e+05 Mflops = 297.34 -Solve time = 0.00 -Solve flops = 1.357600e+04 Mflops = 470.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000120033; expected ratio = 0.0001obtained abs = 1.74005e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00637124; expected ratio = 0.001obtained abs = 2.25899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000388145 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.258320e+05 Mflops = 298.18 -Solve time = 0.00 -Solve flops = 1.357600e+04 Mflops = 451.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.50329e-05; expected ratio = 0.0001obtained abs = 1.37764e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00400481; expected ratio = 0.001obtained abs = 1.41867; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.85 - Final Residual ratio : 0.0116809 - Residual ratio : 0.000843384 - Slope : -0.494227 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.8502 - Final Residual ratio : 0.0146645 - Residual ratio : 0.000526548 - Slope : -0.92785 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.3651 - Final Residual ratio : 0.0133164 - Residual ratio : 0.000469464 - Slope : -0.945059 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.2503 - Final Residual ratio : 0.013076 - Residual ratio : 0.000562401 - Slope : -0.774572 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.1929 - Final Residual ratio : 0.00602144 - Residual ratio : 0.000350227 - Slope : -0.505498 - Tolerance : 0.001 - Number of iterations : 34 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4671 - Final Residual ratio : 0.0084283 - Residual ratio : 0.000625845 - Slope : -0.448622 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.7827 - Final Residual ratio : 0.00999421 - Residual ratio : 0.000781856 - Slope : -0.425756 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.7789 - Final Residual ratio : 0.00806567 - Residual ratio : 0.000631173 - Slope : -0.425693 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.8063 - Final Residual ratio : 0.00679454 - Residual ratio : 0.0005755 - Slope : -0.393317 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1646 - Final Residual ratio : 0.00842136 - Residual ratio : 0.000828502 - Slope : -0.338538 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 108 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 108 - - Mesh vertices: 108 - Mesh triangles: 108 - Mesh edges: 178 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8851 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000399113 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.279830e+05 Mflops = 300.39 -Solve time = 0.00 -Solve flops = 1.376000e+04 Mflops = 443.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0438289; expected ratio = 0.0001obtained abs = 0.000633043; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107694; expected ratio = 0.001obtained abs = 37.0935; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000389099 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.290270e+05 Mflops = 303.52 -Solve time = 0.00 -Solve flops = 1.380600e+04 Mflops = 459.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0122466; expected ratio = 0.0001obtained abs = 0.000176919; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134251; expected ratio = 0.001obtained abs = 48.8547; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000388861 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.292250e+05 Mflops = 304.16 -Solve time = 0.00 -Solve flops = 1.382000e+04 Mflops = 460.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00599911; expected ratio = 0.0001obtained abs = 8.66485e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.20633; expected ratio = 0.001obtained abs = 74.648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000391006 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.278150e+05 Mflops = 302.88 -Solve time = 0.00 -Solve flops = 1.373800e+04 Mflops = 460.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000266373; expected ratio = 0.0001obtained abs = 3.84734e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.215581; expected ratio = 0.001obtained abs = 74.465; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000389814 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.299750e+05 Mflops = 301.52 -Solve time = 0.00 -Solve flops = 1.384800e+04 Mflops = 446.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000804734; expected ratio = 0.0001obtained abs = 1.16233e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.186583; expected ratio = 0.001obtained abs = 68.698; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390768 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.283170e+05 Mflops = 302.70 -Solve time = 0.00 -Solve flops = 1.376600e+04 Mflops = 458.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00075583; expected ratio = 0.0001obtained abs = 1.09172e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125839; expected ratio = 0.001obtained abs = 45.2296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000400066 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.279830e+05 Mflops = 302.59 -Solve time = 0.00 -Solve flops = 1.376000e+04 Mflops = 458.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000339123; expected ratio = 0.0001obtained abs = 4.89813e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0570323; expected ratio = 0.001obtained abs = 20.1424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000391006 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.279830e+05 Mflops = 301.91 -Solve time = 0.00 -Solve flops = 1.376000e+04 Mflops = 458.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00014925; expected ratio = 0.0001obtained abs = 2.15568e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.036824; expected ratio = 0.001obtained abs = 12.905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,108) -time: 0.000390053 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.284330e+05 Mflops = 302.97 -Solve time = 0.00 -Solve flops = 1.377200e+04 Mflops = 458.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.91461e-05; expected ratio = 0.0001obtained abs = 1.28758e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0237304; expected ratio = 0.001obtained abs = 8.37099; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.83282 - Final Residual ratio : 0.00554202 - Residual ratio : 0.000627435 - Slope : -0.275852 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.07897 - Final Residual ratio : 0.00576272 - Residual ratio : 0.000713299 - Slope : -0.260426 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.21395 - Final Residual ratio : 0.00486708 - Residual ratio : 0.000674677 - Slope : -0.240303 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.08322 - Final Residual ratio : 0.00497959 - Residual ratio : 0.000818578 - Slope : -0.209594 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.48712 - Final Residual ratio : 0.00493181 - Residual ratio : 0.000898798 - Slope : -0.189041 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.89334 - Final Residual ratio : 0.00424799 - Residual ratio : 0.000720813 - Slope : -0.189971 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.224 - Final Residual ratio : 0.00606026 - Residual ratio : 0.000973692 - Slope : -0.207265 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.75911 - Final Residual ratio : 0.00445965 - Residual ratio : 0.000774365 - Slope : -0.191822 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.81617 - Final Residual ratio : 0.00474534 - Residual ratio : 0.000985294 - Slope : -0.165911 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8951 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.40089 - Final Residual ratio : 0.00326053 - Residual ratio : 0.000740879 - Slope : -0.157058 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.8951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 9 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 108 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 108 - - Mesh vertices: 109 - Mesh triangles: 110 - Mesh edges: 181 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.8951 -matrix_partition : [5](0,45,90,135,180) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.342600e+05 Mflops = 313.72 -Solve time = 0.00 -Solve flops = 1.421000e+04 Mflops = 458.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0421418; expected ratio = 0.0001obtained abs = 0.000627275; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109942; expected ratio = 0.001obtained abs = 36.3207; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.391260e+05 Mflops = 322.93 -Solve time = 0.00 -Solve flops = 1.440200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00512801; expected ratio = 0.0001obtained abs = 7.64309e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0578216; expected ratio = 0.001obtained abs = 19.2645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.356220e+05 Mflops = 317.61 -Solve time = 0.00 -Solve flops = 1.426400e+04 Mflops = 460.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116323; expected ratio = 0.0001obtained abs = 1.7335e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.034421; expected ratio = 0.001obtained abs = 11.4358; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.356220e+05 Mflops = 315.32 -Solve time = 0.00 -Solve flops = 1.426400e+04 Mflops = 460.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000289394; expected ratio = 0.0001obtained abs = 4.31274e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0227168; expected ratio = 0.001obtained abs = 7.57109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000408173 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.356220e+05 Mflops = 316.90 -Solve time = 0.00 -Solve flops = 1.426400e+04 Mflops = 460.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000142954; expected ratio = 0.0001obtained abs = 2.13039e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.013934; expected ratio = 0.001obtained abs = 4.63879; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.356220e+05 Mflops = 316.02 -Solve time = 0.00 -Solve flops = 1.426400e+04 Mflops = 460.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.54955e-05; expected ratio = 0.0001obtained abs = 9.76056e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00900212; expected ratio = 0.001obtained abs = 2.99875; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.8961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.71744 - Final Residual ratio : 0.00436606 - Residual ratio : 0.000925516 - Slope : -0.157102 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.90491 - Final Residual ratio : 0.00460869 - Residual ratio : 0.000939606 - Slope : -0.163344 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.50761 - Final Residual ratio : 0.00330485 - Residual ratio : 0.000733171 - Slope : -0.1453 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.8991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.94499 - Final Residual ratio : 0.00275551 - Residual ratio : 0.000698485 - Slope : -0.135939 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.8991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.4706 - Final Residual ratio : 0.0160626 - Residual ratio : 0.000784666 - Slope : -0.705328 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.16484 - Final Residual ratio : 0.00501974 - Residual ratio : 0.000700606 - Slope : -0.230962 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.50216 - Final Residual ratio : 0.00381902 - Residual ratio : 0.000848265 - Slope : -0.145108 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.98273 - Final Residual ratio : 0.00313222 - Residual ratio : 0.00078645 - Slope : -0.137228 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.34334 - Final Residual ratio : 0.00315974 - Residual ratio : 0.000727492 - Slope : -0.255305 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.3332 - Final Residual ratio : 0.033914 - Residual ratio : 0.000884718 - Slope : -1.32066 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 110 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 109 - - Mesh vertices: 109 - Mesh triangles: 109 - Mesh edges: 180 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9051 -matrix_partition : [5](0,45,90,135,180) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.303660e+05 Mflops = 297.66 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 451.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0529288; expected ratio = 0.0001obtained abs = 0.000782288; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0339076; expected ratio = 0.001obtained abs = 11.2094; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.332700e+05 Mflops = 296.85 -Solve time = 0.00 -Solve flops = 1.410400e+04 Mflops = 455.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00452156; expected ratio = 0.0001obtained abs = 6.68646e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018754; expected ratio = 0.001obtained abs = 6.2731; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.303660e+05 Mflops = 302.43 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 451.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000678625; expected ratio = 0.0001obtained abs = 1.00346e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0196139; expected ratio = 0.001obtained abs = 6.53819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396013 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.303660e+05 Mflops = 301.76 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 465.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000185696; expected ratio = 0.0001obtained abs = 2.74583e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0206393; expected ratio = 0.001obtained abs = 6.89594; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000392914 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.303660e+05 Mflops = 303.94 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 451.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.33052e-05; expected ratio = 0.0001obtained abs = 1.37967e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0177194; expected ratio = 0.001obtained abs = 5.9097; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.6911 - Final Residual ratio : 0.0416783 - Residual ratio : 0.000892639 - Slope : -1.6086 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.525 - Final Residual ratio : 0.006828 - Residual ratio : 0.000907375 - Slope : -0.259247 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.47941 - Final Residual ratio : 0.0069645 - Residual ratio : 0.000734698 - Slope : -0.315748 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.3346 - Final Residual ratio : 0.00996768 - Residual ratio : 0.000808106 - Slope : -0.424988 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5299 - Final Residual ratio : 0.010946 - Residual ratio : 0.000949351 - Slope : -0.767932 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.12584 - Final Residual ratio : 0.00674778 - Residual ratio : 0.000739415 - Slope : -0.314451 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.63434 - Final Residual ratio : 0.00546171 - Residual ratio : 0.000823249 - Slope : -0.228582 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.9497 - Final Residual ratio : 0.00246702 - Residual ratio : 0.000498417 - Slope : -0.170594 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 282.074 - Final Residual ratio : 0.265765 - Residual ratio : 0.00094218 - Slope : -10.4374 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 247.294 - Final Residual ratio : 0.213741 - Residual ratio : 0.00086432 - Slope : -8.82431 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 109 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 109 - - Mesh vertices: 109 - Mesh triangles: 109 - Mesh edges: 180 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9151 -matrix_partition : [5](0,45,90,135,180) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.364950e+05 Mflops = 308.79 -Solve time = 0.00 -Solve flops = 1.426600e+04 Mflops = 460.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0596938; expected ratio = 0.0001obtained abs = 0.000875752; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144896; expected ratio = 0.001obtained abs = 48.7842; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000402212 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.365110e+05 Mflops = 312.37 -Solve time = 0.00 -Solve flops = 1.426800e+04 Mflops = 446.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00539018; expected ratio = 0.0001obtained abs = 7.91317e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0836935; expected ratio = 0.001obtained abs = 28.2056; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000399113 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.356530e+05 Mflops = 309.73 -Solve time = 0.00 -Solve flops = 1.422000e+04 Mflops = 458.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000556863; expected ratio = 0.0001obtained abs = 8.17458e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.086925; expected ratio = 0.001obtained abs = 29.1754; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396967 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.360550e+05 Mflops = 307.80 -Solve time = 0.00 -Solve flops = 1.425200e+04 Mflops = 459.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000104625; expected ratio = 0.0001obtained abs = 1.53588e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121645; expected ratio = 0.001obtained abs = 39.8487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.360270e+05 Mflops = 310.58 -Solve time = 0.00 -Solve flops = 1.424000e+04 Mflops = 459.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00065755; expected ratio = 0.0001obtained abs = 9.65271e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122234; expected ratio = 0.001obtained abs = 41.424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000399828 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.360010e+05 Mflops = 299.60 -Solve time = 0.00 -Solve flops = 1.424800e+04 Mflops = 445.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000597222; expected ratio = 0.0001obtained abs = 8.76712e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.17017; expected ratio = 0.001obtained abs = 56.3747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.357810e+05 Mflops = 310.70 -Solve time = 0.00 -Solve flops = 1.422800e+04 Mflops = 459.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000235032; expected ratio = 0.0001obtained abs = 3.45022e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.195525; expected ratio = 0.001obtained abs = 68.5141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000394106 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.356190e+05 Mflops = 311.17 -Solve time = 0.00 -Solve flops = 1.421600e+04 Mflops = 441.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000142458; expected ratio = 0.0001obtained abs = 2.09126e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.12761; expected ratio = 0.001obtained abs = 42.4485; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396013 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.360270e+05 Mflops = 310.58 -Solve time = 0.00 -Solve flops = 1.424000e+04 Mflops = 459.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000313329; expected ratio = 0.0001obtained abs = 4.5996e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0744749; expected ratio = 0.001obtained abs = 25.0015; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000393152 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.360270e+05 Mflops = 311.26 -Solve time = 0.00 -Solve flops = 1.424000e+04 Mflops = 459.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00019173; expected ratio = 0.0001obtained abs = 2.81456e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0724485; expected ratio = 0.001obtained abs = 23.9982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000392914 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.360270e+05 Mflops = 310.58 -Solve time = 0.00 -Solve flops = 1.424000e+04 Mflops = 459.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.69025e-05; expected ratio = 0.0001obtained abs = 9.82114e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0912427; expected ratio = 0.001obtained abs = 30.5532; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 106.381 - Final Residual ratio : 0.0924083 - Residual ratio : 0.000868652 - Slope : -3.79603 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 47.7634 - Final Residual ratio : 0.0362141 - Residual ratio : 0.000758196 - Slope : -1.59091 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.7714 - Final Residual ratio : 0.0364982 - Residual ratio : 0.000992572 - Slope : -1.2245 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.5258 - Final Residual ratio : 0.0303531 - Residual ratio : 0.0009332 - Slope : -1.12053 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.3259 - Final Residual ratio : 0.0214325 - Residual ratio : 0.000730838 - Slope : -1.0105 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.1226 - Final Residual ratio : 0.0182784 - Residual ratio : 0.000727567 - Slope : -0.809818 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.9016 - Final Residual ratio : 0.0199562 - Residual ratio : 0.000954767 - Slope : -0.696056 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.8089 - Final Residual ratio : 0.0139926 - Residual ratio : 0.00078571 - Slope : -0.593163 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.1954 - Final Residual ratio : 0.0133373 - Residual ratio : 0.000823521 - Slope : -0.622388 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.3794 - Final Residual ratio : 0.0086817 - Residual ratio : 0.000564501 - Slope : -0.512358 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 11 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 109 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 109 - - Mesh vertices: 109 - Mesh triangles: 109 - Mesh edges: 180 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9251 -matrix_partition : [5](0,45,90,135,180) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.382870e+05 Mflops = 303.83 -Solve time = 0.00 -Solve flops = 1.434400e+04 Mflops = 448.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0668999; expected ratio = 0.0001obtained abs = 0.000976227; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140448; expected ratio = 0.001obtained abs = 46.7644; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000394821 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.387270e+05 Mflops = 309.67 -Solve time = 0.00 -Solve flops = 1.435800e+04 Mflops = 463.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0061951; expected ratio = 0.0001obtained abs = 9.04444e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166239; expected ratio = 0.001obtained abs = 58.1208; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.394350e+05 Mflops = 309.93 -Solve time = 0.00 -Solve flops = 1.440600e+04 Mflops = 464.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000649453; expected ratio = 0.0001obtained abs = 9.48107e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.183005; expected ratio = 0.001obtained abs = 62.0766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000401974 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.382590e+05 Mflops = 300.47 -Solve time = 0.00 -Solve flops = 1.433200e+04 Mflops = 462.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000149787; expected ratio = 0.0001obtained abs = 2.18668e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164082; expected ratio = 0.001obtained abs = 56.9354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396967 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.390510e+05 Mflops = 309.73 -Solve time = 0.00 -Solve flops = 1.438000e+04 Mflops = 463.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000536053; expected ratio = 0.0001obtained abs = 7.82565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.219415; expected ratio = 0.001obtained abs = 75.5272; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000400066 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.383190e+05 Mflops = 310.08 -Solve time = 0.00 -Solve flops = 1.433400e+04 Mflops = 448.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000364113; expected ratio = 0.0001obtained abs = 5.31556e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.178059; expected ratio = 0.001obtained abs = 62.1978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000393867 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.383190e+05 Mflops = 310.91 -Solve time = 0.00 -Solve flops = 1.433400e+04 Mflops = 448.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000106317; expected ratio = 0.0001obtained abs = 1.55208e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0761192; expected ratio = 0.001obtained abs = 26.1158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.00039506 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.378510e+05 Mflops = 309.19 -Solve time = 0.00 -Solve flops = 1.430800e+04 Mflops = 461.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.26381e-05; expected ratio = 0.0001obtained abs = 1.06041e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0698716; expected ratio = 0.001obtained abs = 23.6384; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.4154 - Final Residual ratio : 0.0129643 - Residual ratio : 0.000899333 - Slope : -0.464596 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.9177 - Final Residual ratio : 0.0114454 - Residual ratio : 0.000886028 - Slope : -0.41633 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.1851 - Final Residual ratio : 0.0100375 - Residual ratio : 0.0008974 - Slope : -0.372502 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.90694 - Final Residual ratio : 0.00550792 - Residual ratio : 0.000555965 - Slope : -0.319401 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 3.9301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.46288 - Final Residual ratio : 0.00903517 - Residual ratio : 0.000954802 - Slope : -0.304963 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.47972 - Final Residual ratio : 0.00879426 - Residual ratio : 0.000927692 - Slope : -0.326584 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.17009 - Final Residual ratio : 0.00774148 - Residual ratio : 0.00084421 - Slope : -0.29556 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.28024 - Final Residual ratio : 0.00634509 - Residual ratio : 0.000766293 - Slope : -0.2669 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.15223 - Final Residual ratio : 0.0062565 - Residual ratio : 0.000874761 - Slope : -0.246413 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.48232 - Final Residual ratio : 0.0052058 - Residual ratio : 0.000803077 - Slope : -0.208939 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 109 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 109 - - Mesh vertices: 109 - Mesh triangles: 109 - Mesh edges: 180 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9351 -matrix_partition : [5](0,45,90,135,180) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.380730e+05 Mflops = 306.90 -Solve time = 0.00 -Solve flops = 1.431800e+04 Mflops = 444.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0657472; expected ratio = 0.0001obtained abs = 0.000954987; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119509; expected ratio = 0.001obtained abs = 38.7412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000394821 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.379810e+05 Mflops = 310.15 -Solve time = 0.00 -Solve flops = 1.431200e+04 Mflops = 447.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00618969; expected ratio = 0.0001obtained abs = 8.99412e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.105652; expected ratio = 0.001obtained abs = 34.9539; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000397921 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.380490e+05 Mflops = 308.98 -Solve time = 0.00 -Solve flops = 1.431800e+04 Mflops = 461.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000642956; expected ratio = 0.0001obtained abs = 9.34221e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0922445; expected ratio = 0.001obtained abs = 29.977; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396013 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.383050e+05 Mflops = 308.07 -Solve time = 0.00 -Solve flops = 1.433400e+04 Mflops = 462.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000180814; expected ratio = 0.0001obtained abs = 2.62725e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103344; expected ratio = 0.001obtained abs = 32.9595; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000394821 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.381630e+05 Mflops = 309.89 -Solve time = 0.00 -Solve flops = 1.432400e+04 Mflops = 462.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000239904; expected ratio = 0.0001obtained abs = 3.48586e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102939; expected ratio = 0.001obtained abs = 33.7927; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000394821 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.380490e+05 Mflops = 308.81 -Solve time = 0.00 -Solve flops = 1.431800e+04 Mflops = 461.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000274686; expected ratio = 0.0001obtained abs = 3.99124e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0672149; expected ratio = 0.001obtained abs = 21.8642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396967 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.381090e+05 Mflops = 309.77 -Solve time = 0.00 -Solve flops = 1.432000e+04 Mflops = 462.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000131602; expected ratio = 0.0001obtained abs = 1.91219e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.050727; expected ratio = 0.001obtained abs = 16.3728; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.388410e+05 Mflops = 309.26 -Solve time = 0.00 -Solve flops = 1.436600e+04 Mflops = 463.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000519044; expected ratio = 0.0001obtained abs = 7.54185e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.14312; expected ratio = 0.001obtained abs = 46.7167; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396013 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.385170e+05 Mflops = 310.69 -Solve time = 0.00 -Solve flops = 1.434400e+04 Mflops = 462.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000374291; expected ratio = 0.0001obtained abs = 5.43852e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130481; expected ratio = 0.001obtained abs = 43.1568; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396967 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.381090e+05 Mflops = 308.94 -Solve time = 0.00 -Solve flops = 1.432000e+04 Mflops = 462.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000240664; expected ratio = 0.0001obtained abs = 3.49688e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0538285; expected ratio = 0.001obtained abs = 17.5128; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.00039506 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.380490e+05 Mflops = 308.81 -Solve time = 0.00 -Solve flops = 1.431800e+04 Mflops = 461.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000425929; expected ratio = 0.0001obtained abs = 6.18886e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0905541; expected ratio = 0.001obtained abs = 29.5268; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396967 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.379210e+05 Mflops = 308.52 -Solve time = 0.00 -Solve flops = 1.431000e+04 Mflops = 461.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000380394; expected ratio = 0.0001obtained abs = 5.52719e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.064379; expected ratio = 0.001obtained abs = 20.9997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000396967 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.380490e+05 Mflops = 308.81 -Solve time = 0.00 -Solve flops = 1.431800e+04 Mflops = 461.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.45818e-05; expected ratio = 0.0001obtained abs = 1.08368e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0551085; expected ratio = 0.001obtained abs = 17.7711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.51272 - Final Residual ratio : 0.00644051 - Residual ratio : 0.000988913 - Slope : -0.203321 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.69599 - Final Residual ratio : 0.00527091 - Residual ratio : 0.000787174 - Slope : -0.209085 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.42556 - Final Residual ratio : 0.0041355 - Residual ratio : 0.000643601 - Slope : -0.214047 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.62769 - Final Residual ratio : 0.00523515 - Residual ratio : 0.000930249 - Slope : -0.18137 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.74029 - Final Residual ratio : 0.0037738 - Residual ratio : 0.000796111 - Slope : -0.175427 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.49477 - Final Residual ratio : 0.0042145 - Residual ratio : 0.000937645 - Slope : -0.166317 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.7534 - Final Residual ratio : 0.00293823 - Residual ratio : 0.000618132 - Slope : -0.153241 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.90344 - Final Residual ratio : 0.00404046 - Residual ratio : 0.000824005 - Slope : -0.153106 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 280.69 - Final Residual ratio : 0.268229 - Residual ratio : 0.000955607 - Slope : -23.3684 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9451 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 155.264 - Final Residual ratio : 0.147985 - Residual ratio : 0.000953114 - Slope : -7.38649 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 13 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 109 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 109 - - Mesh vertices: 109 - Mesh triangles: 109 - Mesh edges: 180 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9451 -matrix_partition : [5](0,45,90,135,180) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.385560e+05 Mflops = 312.11 -Solve time = 0.00 -Solve flops = 1.438800e+04 Mflops = 447.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0666489; expected ratio = 0.0001obtained abs = 0.000963524; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.170947; expected ratio = 0.001obtained abs = 58.3836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.00039506 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.377640e+05 Mflops = 313.01 -Solve time = 0.00 -Solve flops = 1.434000e+04 Mflops = 448.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0065008; expected ratio = 0.0001obtained abs = 9.40104e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.136556; expected ratio = 0.001obtained abs = 48.2637; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000398159 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.382320e+05 Mflops = 314.08 -Solve time = 0.00 -Solve flops = 1.436600e+04 Mflops = 463.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000680916; expected ratio = 0.0001obtained abs = 9.84659e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0924163; expected ratio = 0.001obtained abs = 31.857; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.381480e+05 Mflops = 304.97 -Solve time = 0.00 -Solve flops = 1.436400e+04 Mflops = 463.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000115111; expected ratio = 0.0001obtained abs = 1.6646e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116532; expected ratio = 0.001obtained abs = 38.9549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.382320e+05 Mflops = 314.76 -Solve time = 0.00 -Solve flops = 1.436600e+04 Mflops = 463.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00041933; expected ratio = 0.0001obtained abs = 6.0639e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120958; expected ratio = 0.001obtained abs = 41.8353; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000397921 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.369280e+05 Mflops = 311.96 -Solve time = 0.00 -Solve flops = 1.430800e+04 Mflops = 461.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000445036; expected ratio = 0.0001obtained abs = 6.43559e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11853; expected ratio = 0.001obtained abs = 41.471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000398874 -"finished parallel building" : finished parallel building -matrix size in solver: 180 -RHS size in solver: 180 -Factor time = 0.00 -Factor flops = 1.373560e+05 Mflops = 314.30 -Solve time = 0.00 -Solve flops = 1.431600e+04 Mflops = 448.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.97838e-05; expected ratio = 0.0001obtained abs = 8.64522e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11258; expected ratio = 0.001obtained abs = 38.057; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 70.9066 - Final Residual ratio : 0.0489219 - Residual ratio : 0.000689948 - Slope : -2.7253 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8764 - Final Residual ratio : 0.0117285 - Residual ratio : 0.000910851 - Slope : -0.414988 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.38526 - Final Residual ratio : 0.00638467 - Residual ratio : 0.000761416 - Slope : -0.288927 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.33305 - Final Residual ratio : 0.00548656 - Residual ratio : 0.000748197 - Slope : -0.244252 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.49146 - Final Residual ratio : 0.0065267 - Residual ratio : 0.000871219 - Slope : -0.249498 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.13624 - Final Residual ratio : 0.00578633 - Residual ratio : 0.00071118 - Slope : -0.271015 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.63162 - Final Residual ratio : 0.00818138 - Residual ratio : 0.000947837 - Slope : -0.29736 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.93358 - Final Residual ratio : 0.00598322 - Residual ratio : 0.000669745 - Slope : -0.307848 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.2978 - Final Residual ratio : 0.0449058 - Residual ratio : 0.000969936 - Slope : -1.65189 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.5019 - Final Residual ratio : 0.0195517 - Residual ratio : 0.000737746 - Slope : -0.913183 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 109 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 107 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 107 - - Mesh vertices: 107 - Mesh triangles: 157 - Mesh edges: 263 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 157 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 107 - Input triangles: 105 - - Mesh vertices: 108 - Mesh triangles: 107 - Mesh edges: 177 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9551 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.406500e+05 Mflops = 310.49 -Solve time = 0.00 -Solve flops = 1.432600e+04 Mflops = 462.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0655364; expected ratio = 0.0001obtained abs = 0.000952814; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.157652; expected ratio = 0.001obtained abs = 51.9568; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.395060e+05 Mflops = 312.74 -Solve time = 0.00 -Solve flops = 1.425800e+04 Mflops = 460.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00637598; expected ratio = 0.0001obtained abs = 9.27152e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.136575; expected ratio = 0.001obtained abs = 46.7648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000414848 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.399140e+05 Mflops = 313.82 -Solve time = 0.00 -Solve flops = 1.428200e+04 Mflops = 475.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000672851; expected ratio = 0.0001obtained abs = 9.78376e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0503014; expected ratio = 0.001obtained abs = 16.8225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.399140e+05 Mflops = 313.82 -Solve time = 0.00 -Solve flops = 1.428200e+04 Mflops = 475.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000100349; expected ratio = 0.0001obtained abs = 1.45916e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0443521; expected ratio = 0.001obtained abs = 14.7581; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.402980e+05 Mflops = 311.85 -Solve time = 0.00 -Solve flops = 1.430600e+04 Mflops = 461.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000467266; expected ratio = 0.0001obtained abs = 6.79448e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.135496; expected ratio = 0.001obtained abs = 44.9416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.397860e+05 Mflops = 313.36 -Solve time = 0.00 -Solve flops = 1.427400e+04 Mflops = 460.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000466684; expected ratio = 0.0001obtained abs = 6.78599e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.18085; expected ratio = 0.001obtained abs = 63.3616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.399140e+05 Mflops = 314.32 -Solve time = 0.00 -Solve flops = 1.428200e+04 Mflops = 460.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000106267; expected ratio = 0.0001obtained abs = 1.54521e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.134841; expected ratio = 0.001obtained abs = 44.8895; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.405780e+05 Mflops = 306.94 -Solve time = 0.00 -Solve flops = 1.432200e+04 Mflops = 462.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00035306; expected ratio = 0.0001obtained abs = 5.1338e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130744; expected ratio = 0.001obtained abs = 43.5156; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.397860e+05 Mflops = 313.53 -Solve time = 0.00 -Solve flops = 1.427400e+04 Mflops = 457.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000332356; expected ratio = 0.0001obtained abs = 4.83273e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.158191; expected ratio = 0.001obtained abs = 55.662; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.402540e+05 Mflops = 313.91 -Solve time = 0.00 -Solve flops = 1.430000e+04 Mflops = 457.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000148335; expected ratio = 0.0001obtained abs = 2.1569e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146996; expected ratio = 0.001obtained abs = 49.0569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.405780e+05 Mflops = 310.98 -Solve time = 0.00 -Solve flops = 1.432200e+04 Mflops = 462.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000287507; expected ratio = 0.0001obtained abs = 4.18058e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.133872; expected ratio = 0.001obtained abs = 43.8557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.399140e+05 Mflops = 313.82 -Solve time = 0.00 -Solve flops = 1.428200e+04 Mflops = 460.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000842881; expected ratio = 0.0001obtained abs = 1.22562e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.149505; expected ratio = 0.001obtained abs = 51.1007; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.405780e+05 Mflops = 310.98 -Solve time = 0.00 -Solve flops = 1.432200e+04 Mflops = 462.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000931874; expected ratio = 0.0001obtained abs = 1.35503e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.190045; expected ratio = 0.001obtained abs = 63.0334; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.399140e+05 Mflops = 314.32 -Solve time = 0.00 -Solve flops = 1.428200e+04 Mflops = 460.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000327117; expected ratio = 0.0001obtained abs = 4.75654e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.190046; expected ratio = 0.001obtained abs = 66.3916; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.397280e+05 Mflops = 314.58 -Solve time = 0.00 -Solve flops = 1.427200e+04 Mflops = 460.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.1954e-05; expected ratio = 0.0001obtained abs = 1.33708e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.12637; expected ratio = 0.001obtained abs = 41.9924; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.1965 - Final Residual ratio : 0.0185539 - Residual ratio : 0.000875328 - Slope : -0.756354 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.6865 - Final Residual ratio : 0.00722 - Residual ratio : 0.000745367 - Slope : -0.322643 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.9586 - Final Residual ratio : 0.0296042 - Residual ratio : 0.00098817 - Slope : -1.03203 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 51.4478 - Final Residual ratio : 0.0501125 - Residual ratio : 0.000974045 - Slope : -2.23468 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.9417 - Final Residual ratio : 0.0169106 - Residual ratio : 0.000998168 - Slope : -0.67699 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.9711 - Final Residual ratio : 0.0153137 - Residual ratio : 0.000852125 - Slope : -0.641279 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.15848 - Final Residual ratio : 0.00505422 - Residual ratio : 0.000706047 - Slope : -0.24667 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.85536 - Final Residual ratio : 0.0060616 - Residual ratio : 0.000884212 - Slope : -0.263435 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.89584 - Final Residual ratio : 0.0066482 - Residual ratio : 0.000964089 - Slope : -0.237558 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.68019 - Final Residual ratio : 0.00444462 - Residual ratio : 0.000665343 - Slope : -0.222525 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 15 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 107 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 107 - - Mesh vertices: 108 - Mesh triangles: 107 - Mesh edges: 177 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9651 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.395060e+05 Mflops = 312.24 -Solve time = 0.00 -Solve flops = 1.425800e+04 Mflops = 460.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0664443; expected ratio = 0.0001obtained abs = 0.000963062; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0867459; expected ratio = 0.001obtained abs = 28.5392; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.392600e+05 Mflops = 313.02 -Solve time = 0.00 -Solve flops = 1.424600e+04 Mflops = 474.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00645932; expected ratio = 0.0001obtained abs = 9.36319e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117961; expected ratio = 0.001obtained abs = 40.2239; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.392600e+05 Mflops = 312.19 -Solve time = 0.00 -Solve flops = 1.424600e+04 Mflops = 474.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000682269; expected ratio = 0.0001obtained abs = 9.8896e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0963791; expected ratio = 0.001obtained abs = 31.8322; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.392600e+05 Mflops = 313.02 -Solve time = 0.00 -Solve flops = 1.424600e+04 Mflops = 474.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000132151; expected ratio = 0.0001obtained abs = 1.91556e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0583246; expected ratio = 0.001obtained abs = 19.5824; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.392600e+05 Mflops = 312.85 -Solve time = 0.00 -Solve flops = 1.424600e+04 Mflops = 474.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162927; expected ratio = 0.0001obtained abs = 2.36166e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0424917; expected ratio = 0.001obtained abs = 14.0897; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.402980e+05 Mflops = 313.17 -Solve time = 0.00 -Solve flops = 1.430600e+04 Mflops = 461.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000379729; expected ratio = 0.0001obtained abs = 5.50429e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11351; expected ratio = 0.001obtained abs = 37.9537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000414848 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.397860e+05 Mflops = 314.20 -Solve time = 0.00 -Solve flops = 1.427400e+04 Mflops = 460.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000512464; expected ratio = 0.0001obtained abs = 7.42826e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.173087; expected ratio = 0.001obtained abs = 60.8568; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.397860e+05 Mflops = 305.21 -Solve time = 0.00 -Solve flops = 1.427400e+04 Mflops = 460.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.64685e-05; expected ratio = 0.0001obtained abs = 1.39832e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.149366; expected ratio = 0.001obtained abs = 49.6641; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.33732 - Final Residual ratio : 0.00471726 - Residual ratio : 0.000744362 - Slope : -0.211087 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.88191 - Final Residual ratio : 0.0052125 - Residual ratio : 0.000886193 - Slope : -0.202645 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.4645 - Final Residual ratio : 0.00510465 - Residual ratio : 0.000934147 - Slope : -0.3033 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.5247 - Final Residual ratio : 0.010099 - Residual ratio : 0.00057627 - Slope : -0.583821 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.9931 - Final Residual ratio : 0.0328544 - Residual ratio : 0.000938882 - Slope : -1.5891 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.4596 - Final Residual ratio : 0.013467 - Residual ratio : 0.000871108 - Slope : -0.532627 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.5784 - Final Residual ratio : 0.016375 - Residual ratio : 0.000881396 - Slope : -0.713926 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.42808 - Final Residual ratio : 0.00497223 - Residual ratio : 0.000916019 - Slope : -0.193683 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.63934 - Final Residual ratio : 0.00437887 - Residual ratio : 0.000943857 - Slope : -0.193123 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.8749 - Final Residual ratio : 0.00318369 - Residual ratio : 0.000653078 - Slope : -0.187374 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 107 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 107 - - Mesh vertices: 108 - Mesh triangles: 107 - Mesh edges: 177 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9751 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.408230e+05 Mflops = 309.57 -Solve time = 0.00 -Solve flops = 1.435200e+04 Mflops = 463.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0670179; expected ratio = 0.0001obtained abs = 0.000968039; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139537; expected ratio = 0.001obtained abs = 46.0178; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.396230e+05 Mflops = 311.00 -Solve time = 0.00 -Solve flops = 1.428000e+04 Mflops = 460.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00652961; expected ratio = 0.0001obtained abs = 9.43188e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130286; expected ratio = 0.001obtained abs = 44.8535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.401030e+05 Mflops = 311.91 -Solve time = 0.00 -Solve flops = 1.430800e+04 Mflops = 461.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000784897; expected ratio = 0.0001obtained abs = 1.13372e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0497155; expected ratio = 0.001obtained abs = 16.74; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.400310e+05 Mflops = 311.09 -Solve time = 0.00 -Solve flops = 1.430400e+04 Mflops = 476.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000143458; expected ratio = 0.0001obtained abs = 2.07214e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.054344; expected ratio = 0.001obtained abs = 18.0662; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.404150e+05 Mflops = 305.94 -Solve time = 0.00 -Solve flops = 1.432800e+04 Mflops = 462.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000418059; expected ratio = 0.0001obtained abs = 6.03862e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.12991; expected ratio = 0.001obtained abs = 43.2051; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.399030e+05 Mflops = 310.97 -Solve time = 0.00 -Solve flops = 1.429600e+04 Mflops = 475.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000378258; expected ratio = 0.0001obtained abs = 5.46368e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159836; expected ratio = 0.001obtained abs = 55.5948; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.396230e+05 Mflops = 310.18 -Solve time = 0.00 -Solve flops = 1.428000e+04 Mflops = 479.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.70529e-05; expected ratio = 0.0001obtained abs = 1.11297e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121159; expected ratio = 0.001obtained abs = 40.123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 299.998 - Final Residual ratio : 0.269743 - Residual ratio : 0.000899148 - Slope : -23.056 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9771 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 139.13 - Final Residual ratio : 0.136424 - Residual ratio : 0.000980551 - Slope : -19.8562 - Tolerance : 0.001 - Number of iterations : 7 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.8561 - Final Residual ratio : 0.0423714 - Residual ratio : 0.000867269 - Slope : -1.87745 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 110.519 - Final Residual ratio : 0.0944641 - Residual ratio : 0.000854731 - Slope : -3.80775 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 77.1333 - Final Residual ratio : 0.0691939 - Residual ratio : 0.00089707 - Slope : -2.75229 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.1988 - Final Residual ratio : 0.0268687 - Residual ratio : 0.000809327 - Slope : -1.18471 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.6783 - Final Residual ratio : 0.0245538 - Residual ratio : 0.000956209 - Slope : -0.986682 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.3428 - Final Residual ratio : 0.0192455 - Residual ratio : 0.000824473 - Slope : -0.89706 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.0209 - Final Residual ratio : 0.0206858 - Residual ratio : 0.000984056 - Slope : -1.75002 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.1729 - Final Residual ratio : 0.0224375 - Residual ratio : 0.000656587 - Slope : -1.13835 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 107 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 107 - - Mesh vertices: 108 - Mesh triangles: 107 - Mesh edges: 177 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9851 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000418186 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.356240e+05 Mflops = 321.38 -Solve time = 0.00 -Solve flops = 1.413000e+04 Mflops = 455.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.109797; expected ratio = 0.0001obtained abs = 0.00155565; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189174; expected ratio = 0.001obtained abs = 63.6282; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.336600e+05 Mflops = 325.94 -Solve time = 0.00 -Solve flops = 1.402200e+04 Mflops = 452.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00827439; expected ratio = 0.0001obtained abs = 0.000117309; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.141022; expected ratio = 0.001obtained abs = 48.2281; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.332520e+05 Mflops = 326.65 -Solve time = 0.00 -Solve flops = 1.399800e+04 Mflops = 451.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00169581; expected ratio = 0.0001obtained abs = 2.4036e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0940109; expected ratio = 0.001obtained abs = 31.0619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.339160e+05 Mflops = 325.05 -Solve time = 0.00 -Solve flops = 1.403800e+04 Mflops = 452.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00014962; expected ratio = 0.0001obtained abs = 2.12072e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0852338; expected ratio = 0.001obtained abs = 28.1277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000477076 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.332520e+05 Mflops = 327.42 -Solve time = 0.00 -Solve flops = 1.399800e+04 Mflops = 451.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000203024; expected ratio = 0.0001obtained abs = 2.87767e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.158353; expected ratio = 0.001obtained abs = 55.3868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.340900e+05 Mflops = 326.42 -Solve time = 0.00 -Solve flops = 1.405000e+04 Mflops = 453.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00027248; expected ratio = 0.0001obtained abs = 3.86213e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.139334; expected ratio = 0.001obtained abs = 46.4978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.327840e+05 Mflops = 325.50 -Solve time = 0.00 -Solve flops = 1.397200e+04 Mflops = 450.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000152023; expected ratio = 0.0001obtained abs = 2.15476e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140122; expected ratio = 0.001obtained abs = 47.8544; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.335760e+05 Mflops = 323.29 -Solve time = 0.00 -Solve flops = 1.402000e+04 Mflops = 470.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000223629; expected ratio = 0.0001obtained abs = 3.1697e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.167299; expected ratio = 0.001obtained abs = 55.1498; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.333060e+05 Mflops = 326.02 -Solve time = 0.00 -Solve flops = 1.400200e+04 Mflops = 435.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00028156; expected ratio = 0.0001obtained abs = 3.99085e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140494; expected ratio = 0.001obtained abs = 48.0987; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.331920e+05 Mflops = 326.50 -Solve time = 0.00 -Solve flops = 1.399600e+04 Mflops = 465.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000319657; expected ratio = 0.0001obtained abs = 4.53083e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0938724; expected ratio = 0.001obtained abs = 31.8017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000408173 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.332520e+05 Mflops = 325.70 -Solve time = 0.00 -Solve flops = 1.399800e+04 Mflops = 451.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000204008; expected ratio = 0.0001obtained abs = 2.89159e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0684096; expected ratio = 0.001obtained abs = 22.9518; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.339840e+05 Mflops = 324.46 -Solve time = 0.00 -Solve flops = 1.404400e+04 Mflops = 453.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000630037; expected ratio = 0.0001obtained abs = 8.93017e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.180751; expected ratio = 0.001obtained abs = 61.7238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.332520e+05 Mflops = 316.48 -Solve time = 0.00 -Solve flops = 1.399800e+04 Mflops = 451.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000417458; expected ratio = 0.0001obtained abs = 5.91709e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166848; expected ratio = 0.001obtained abs = 57.7044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.332520e+05 Mflops = 326.65 -Solve time = 0.00 -Solve flops = 1.399800e+04 Mflops = 448.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000305374; expected ratio = 0.0001obtained abs = 4.32833e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0741629; expected ratio = 0.001obtained abs = 25.1731; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.327840e+05 Mflops = 324.56 -Solve time = 0.00 -Solve flops = 1.397200e+04 Mflops = 468.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000322813; expected ratio = 0.0001obtained abs = 4.57553e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104519; expected ratio = 0.001obtained abs = 35.5586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.331360e+05 Mflops = 325.42 -Solve time = 0.00 -Solve flops = 1.399200e+04 Mflops = 465.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0003005; expected ratio = 0.0001obtained abs = 4.25926e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0838586; expected ratio = 0.001obtained abs = 28.3891; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.327840e+05 Mflops = 325.50 -Solve time = 0.00 -Solve flops = 1.397200e+04 Mflops = 450.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.94966e-05; expected ratio = 0.0001obtained abs = 9.85033e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0948124; expected ratio = 0.001obtained abs = 31.912; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 60.767 - Final Residual ratio : 0.0550229 - Residual ratio : 0.000905472 - Slope : -2.42848 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.7465 - Final Residual ratio : 0.0226254 - Residual ratio : 0.00073587 - Slope : -1.05944 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.1799 - Final Residual ratio : 0.0178844 - Residual ratio : 0.000844406 - Slope : -0.783777 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.2688 - Final Residual ratio : 0.00761303 - Residual ratio : 0.00062052 - Slope : -0.395522 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.4238 - Final Residual ratio : 0.00967366 - Residual ratio : 0.000846801 - Slope : -0.38047 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.016 - Final Residual ratio : 0.00428758 - Residual ratio : 0.000389213 - Slope : -0.367057 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3882 - Final Residual ratio : 0.00710241 - Residual ratio : 0.000683698 - Slope : -0.346038 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.60407 - Final Residual ratio : 0.00936948 - Residual ratio : 0.000975573 - Slope : -0.369027 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.83201 - Final Residual ratio : 0.00805396 - Residual ratio : 0.000911906 - Slope : -0.441198 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.17961 - Final Residual ratio : 0.00592592 - Residual ratio : 0.000724474 - Slope : -0.302729 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 3.9951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 17 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 107 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 107 - - Mesh vertices: 108 - Mesh triangles: 107 - Mesh edges: 177 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 3.9951 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.328340e+05 Mflops = 323.17 -Solve time = 0.00 -Solve flops = 1.396800e+04 Mflops = 450.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0912279; expected ratio = 0.0001obtained abs = 0.0012706; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.455795; expected ratio = 0.001obtained abs = 144.919; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.330280e+05 Mflops = 326.87 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 465.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0125832; expected ratio = 0.0001obtained abs = 0.000175654; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110372; expected ratio = 0.001obtained abs = 35.8209; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.330280e+05 Mflops = 326.87 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 451.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00125206; expected ratio = 0.0001obtained abs = 1.74738e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0521516; expected ratio = 0.001obtained abs = 16.9467; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.330280e+05 Mflops = 327.63 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 451.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000161045; expected ratio = 0.0001obtained abs = 2.2476e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0437667; expected ratio = 0.001obtained abs = 14.2594; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.330280e+05 Mflops = 326.87 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 465.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000133014; expected ratio = 0.0001obtained abs = 1.85638e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0402934; expected ratio = 0.001obtained abs = 13.1206; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.330280e+05 Mflops = 326.87 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 469.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000128384; expected ratio = 0.0001obtained abs = 1.79177e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0375073; expected ratio = 0.001obtained abs = 12.1927; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.330280e+05 Mflops = 326.87 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 465.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000109521; expected ratio = 0.0001obtained abs = 1.52851e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0319482; expected ratio = 0.001obtained abs = 10.4027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.330280e+05 Mflops = 327.83 -Solve time = 0.00 -Solve flops = 1.398000e+04 Mflops = 465.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.68398e-05; expected ratio = 0.0001obtained abs = 1.35153e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0275659; expected ratio = 0.001obtained abs = 8.96946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 3.9961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.99943 - Final Residual ratio : 0.00563732 - Residual ratio : 0.000704715 - Slope : -0.285493 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.9679 - Final Residual ratio : 0.00766115 - Residual ratio : 0.000961502 - Slope : -0.274491 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.81025 - Final Residual ratio : 0.00529157 - Residual ratio : 0.000677517 - Slope : -0.251773 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 3.9991 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.35005 - Final Residual ratio : 0.00727469 - Residual ratio : 0.000989748 - Slope : -0.236864 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 3.9991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.75235 - Final Residual ratio : 0.00630334 - Residual ratio : 0.000933503 - Slope : -0.217614 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.15591 - Final Residual ratio : 0.00493935 - Residual ratio : 0.000802375 - Slope : -0.236576 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.65349 - Final Residual ratio : 0.00359877 - Residual ratio : 0.000636558 - Slope : -0.182254 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.28345 - Final Residual ratio : 0.00324586 - Residual ratio : 0.000614346 - Slope : -0.176007 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.04769 - Final Residual ratio : 0.00496885 - Residual ratio : 0.000984381 - Slope : -0.193951 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.93144 - Final Residual ratio : 0.00482936 - Residual ratio : 0.0009793 - Slope : -0.169883 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 107 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 107 - - Mesh vertices: 108 - Mesh triangles: 107 - Mesh edges: 177 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0051 -matrix_partition : [5](0,44,88,132,177) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.324370e+05 Mflops = 330.45 -Solve time = 0.00 -Solve flops = 1.393000e+04 Mflops = 449.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0879051; expected ratio = 0.0001obtained abs = 0.0012094; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.323789; expected ratio = 0.001obtained abs = 111.253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.288210e+05 Mflops = 325.29 -Solve time = 0.00 -Solve flops = 1.373800e+04 Mflops = 457.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0177448; expected ratio = 0.0001obtained abs = 0.000243984; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.227935; expected ratio = 0.001obtained abs = 76.7006; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.273730e+05 Mflops = 322.41 -Solve time = 0.00 -Solve flops = 1.366400e+04 Mflops = 454.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00410829; expected ratio = 0.0001obtained abs = 5.64464e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.320861; expected ratio = 0.001obtained abs = 109.746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.287650e+05 Mflops = 325.94 -Solve time = 0.00 -Solve flops = 1.373800e+04 Mflops = 457.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00132428; expected ratio = 0.0001obtained abs = 1.81927e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.23397; expected ratio = 0.001obtained abs = 77.4811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.281530e+05 Mflops = 325.96 -Solve time = 0.00 -Solve flops = 1.370200e+04 Mflops = 442.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000545581; expected ratio = 0.0001obtained abs = 7.49482e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121352; expected ratio = 0.001obtained abs = 40.1005; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.285610e+05 Mflops = 326.41 -Solve time = 0.00 -Solve flops = 1.372600e+04 Mflops = 456.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000338349; expected ratio = 0.0001obtained abs = 4.64791e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0977128; expected ratio = 0.001obtained abs = 32.4147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000410795 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.273730e+05 Mflops = 322.41 -Solve time = 0.00 -Solve flops = 1.366400e+04 Mflops = 454.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000336701; expected ratio = 0.0001obtained abs = 4.62527e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0805309; expected ratio = 0.001obtained abs = 26.9801; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.275570e+05 Mflops = 322.88 -Solve time = 0.00 -Solve flops = 1.366800e+04 Mflops = 454.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000321252; expected ratio = 0.0001obtained abs = 4.41302e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.070311; expected ratio = 0.001obtained abs = 23.7405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.276850e+05 Mflops = 323.99 -Solve time = 0.00 -Solve flops = 1.367600e+04 Mflops = 458.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000158122; expected ratio = 0.0001obtained abs = 2.17206e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0935036; expected ratio = 0.001obtained abs = 31.071; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.281650e+05 Mflops = 322.86 -Solve time = 0.00 -Solve flops = 1.371200e+04 Mflops = 442.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000761576; expected ratio = 0.0001obtained abs = 1.04616e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172376; expected ratio = 0.001obtained abs = 57.6367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.280930e+05 Mflops = 324.43 -Solve time = 0.00 -Solve flops = 1.370000e+04 Mflops = 456.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000629959; expected ratio = 0.0001obtained abs = 8.65381e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117308; expected ratio = 0.001obtained abs = 40.0523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.280930e+05 Mflops = 325.22 -Solve time = 0.00 -Solve flops = 1.370000e+04 Mflops = 442.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000327027; expected ratio = 0.0001obtained abs = 4.49233e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0716485; expected ratio = 0.001obtained abs = 24.6532; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000413179 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.280250e+05 Mflops = 324.85 -Solve time = 0.00 -Solve flops = 1.369400e+04 Mflops = 455.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00014768; expected ratio = 0.0001obtained abs = 2.02861e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164116; expected ratio = 0.001obtained abs = 55.0159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.289450e+05 Mflops = 325.61 -Solve time = 0.00 -Solve flops = 1.375000e+04 Mflops = 461.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000253758; expected ratio = 0.0001obtained abs = 3.48576e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.150747; expected ratio = 0.001obtained abs = 49.3312; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.273730e+05 Mflops = 322.41 -Solve time = 0.00 -Solve flops = 1.366400e+04 Mflops = 454.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000292776; expected ratio = 0.0001obtained abs = 4.02182e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11752; expected ratio = 0.001obtained abs = 39.6304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.280930e+05 Mflops = 324.24 -Solve time = 0.00 -Solve flops = 1.370000e+04 Mflops = 459.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000288191; expected ratio = 0.0001obtained abs = 3.95886e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0565853; expected ratio = 0.001obtained abs = 18.9073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.276850e+05 Mflops = 323.40 -Solve time = 0.00 -Solve flops = 1.367600e+04 Mflops = 455.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000184542; expected ratio = 0.0001obtained abs = 2.53502e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0552173; expected ratio = 0.001obtained abs = 18.3688; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.273730e+05 Mflops = 323.19 -Solve time = 0.00 -Solve flops = 1.366400e+04 Mflops = 440.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000418369; expected ratio = 0.0001obtained abs = 5.74702e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.114947; expected ratio = 0.001obtained abs = 38.6863; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.280250e+05 Mflops = 324.85 -Solve time = 0.00 -Solve flops = 1.369400e+04 Mflops = 459.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000368845; expected ratio = 0.0001obtained abs = 5.06677e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106817; expected ratio = 0.001obtained abs = 36.5561; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,26,52,78,107) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 177 -RHS size in solver: 177 -Factor time = 0.00 -Factor flops = 1.280930e+05 Mflops = 325.02 -Solve time = 0.00 -Solve flops = 1.370000e+04 Mflops = 459.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000132687; expected ratio = 0.0001obtained abs = 1.82267e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0899707; expected ratio = 0.001obtained abs = 30.0133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.8148 - Final Residual ratio : 0.0121401 - Residual ratio : 0.000612677 - Slope : -0.66009 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0071 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.4454 - Final Residual ratio : 0.0456769 - Residual ratio : 0.000983453 - Slope : -1.65713 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.4189 - Final Residual ratio : 0.0371248 - Residual ratio : 0.000766741 - Slope : -1.61273 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.1263 - Final Residual ratio : 0.01738 - Residual ratio : 0.000908698 - Slope : -0.68246 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.73149 - Final Residual ratio : 0.00869242 - Residual ratio : 0.000995525 - Slope : -0.29076 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.07502 - Final Residual ratio : 0.00506676 - Residual ratio : 0.000627461 - Slope : -0.260321 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.6444 - Final Residual ratio : 0.00488157 - Residual ratio : 0.000638581 - Slope : -0.246436 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.59799 - Final Residual ratio : 0.00439559 - Residual ratio : 0.000666201 - Slope : -0.212697 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.28877 - Final Residual ratio : 0.0032639 - Residual ratio : 0.000617137 - Slope : -0.1705 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.37999 - Final Residual ratio : 0.00361719 - Residual ratio : 0.000825846 - Slope : -0.145879 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 107 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 108 - - Mesh vertices: 109 - Mesh triangles: 110 - Mesh edges: 182 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0151 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.418590e+05 Mflops = 320.24 -Solve time = 0.00 -Solve flops = 1.457800e+04 Mflops = 470.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.098438; expected ratio = 0.0001obtained abs = 0.00131953; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.323752; expected ratio = 0.001obtained abs = 114.584; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.425060e+05 Mflops = 326.08 -Solve time = 0.00 -Solve flops = 1.459200e+04 Mflops = 470.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0263374; expected ratio = 0.0001obtained abs = 0.000353399; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0772568; expected ratio = 0.001obtained abs = 28.3894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000415802 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.427420e+05 Mflops = 325.91 -Solve time = 0.00 -Solve flops = 1.461000e+04 Mflops = 471.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0127791; expected ratio = 0.0001obtained abs = 0.000171092; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0566586; expected ratio = 0.001obtained abs = 20.8103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.425850e+05 Mflops = 326.27 -Solve time = 0.00 -Solve flops = 1.461800e+04 Mflops = 471.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00619929; expected ratio = 0.0001obtained abs = 8.29318e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0287348; expected ratio = 0.001obtained abs = 10.5279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.425850e+05 Mflops = 325.56 -Solve time = 0.00 -Solve flops = 1.461800e+04 Mflops = 457.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00319277; expected ratio = 0.0001obtained abs = 4.26929e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0205907; expected ratio = 0.001obtained abs = 7.53948; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000404835 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.426130e+05 Mflops = 322.63 -Solve time = 0.00 -Solve flops = 1.463000e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00153476; expected ratio = 0.0001obtained abs = 2.05185e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0797497; expected ratio = 0.001obtained abs = 29.1904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.429250e+05 Mflops = 327.04 -Solve time = 0.00 -Solve flops = 1.463600e+04 Mflops = 458.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000829794; expected ratio = 0.0001obtained abs = 1.10925e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10543; expected ratio = 0.001obtained abs = 39.7834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.417610e+05 Mflops = 324.38 -Solve time = 0.00 -Solve flops = 1.459400e+04 Mflops = 470.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000367059; expected ratio = 0.0001obtained abs = 4.90651e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116027; expected ratio = 0.001obtained abs = 42.8217; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.413290e+05 Mflops = 324.10 -Solve time = 0.00 -Solve flops = 1.457000e+04 Mflops = 470.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000813941; expected ratio = 0.0001obtained abs = 1.088e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.157209; expected ratio = 0.001obtained abs = 57.4179; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000404835 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.414210e+05 Mflops = 323.60 -Solve time = 0.00 -Solve flops = 1.457600e+04 Mflops = 456.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000770493; expected ratio = 0.0001obtained abs = 1.02991e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.148738; expected ratio = 0.001obtained abs = 56.9508; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.414210e+05 Mflops = 324.31 -Solve time = 0.00 -Solve flops = 1.457600e+04 Mflops = 470.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000188709; expected ratio = 0.0001obtained abs = 2.52241e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0976747; expected ratio = 0.001obtained abs = 36.0651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.412930e+05 Mflops = 323.31 -Solve time = 0.00 -Solve flops = 1.456800e+04 Mflops = 470.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.31313e-05; expected ratio = 0.0001obtained abs = 7.10188e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0474582; expected ratio = 0.001obtained abs = 17.497; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.7998 - Final Residual ratio : 0.014906 - Residual ratio : 0.000653779 - Slope : -0.759495 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.5143 - Final Residual ratio : 0.0320803 - Residual ratio : 0.000689686 - Slope : -1.54941 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.0979 - Final Residual ratio : 0.033629 - Residual ratio : 0.000729511 - Slope : -1.53548 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.2746 - Final Residual ratio : 0.0198143 - Residual ratio : 0.000457873 - Slope : -1.39531 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0201 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.3586 - Final Residual ratio : 0.0165925 - Residual ratio : 0.000606483 - Slope : -0.9114 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.6517 - Final Residual ratio : 0.0189855 - Residual ratio : 0.000919322 - Slope : -0.687756 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.2824 - Final Residual ratio : 0.0162615 - Residual ratio : 0.000843334 - Slope : -0.664351 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0231 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.142 - Final Residual ratio : 0.0130753 - Residual ratio : 0.000649152 - Slope : -0.649321 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.8217 - Final Residual ratio : 0.0114486 - Residual ratio : 0.000577579 - Slope : -0.683113 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.9443 - Final Residual ratio : 0.00515771 - Residual ratio : 0.00028743 - Slope : -0.543609 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 12 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 110 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 110 - - Mesh vertices: 109 - Mesh triangles: 110 - Mesh edges: 182 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0251 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.619000e+05 Mflops = 347.34 -Solve time = 0.00 -Solve flops = 1.539600e+04 Mflops = 481.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.11391; expected ratio = 0.0001obtained abs = 0.00149911; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.590811; expected ratio = 0.001obtained abs = 171.546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.621960e+05 Mflops = 346.56 -Solve time = 0.00 -Solve flops = 1.540800e+04 Mflops = 482.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0285394; expected ratio = 0.0001obtained abs = 0.000376936; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.144066; expected ratio = 0.001obtained abs = 44.9231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.615960e+05 Mflops = 344.58 -Solve time = 0.00 -Solve flops = 1.538400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00317258; expected ratio = 0.0001obtained abs = 4.18722e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.154335; expected ratio = 0.001obtained abs = 46.7615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.617280e+05 Mflops = 344.86 -Solve time = 0.00 -Solve flops = 1.538200e+04 Mflops = 481.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000664008; expected ratio = 0.0001obtained abs = 8.76376e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.184693; expected ratio = 0.001obtained abs = 54.8002; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.608480e+05 Mflops = 344.38 -Solve time = 0.00 -Solve flops = 1.534200e+04 Mflops = 480.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000318368; expected ratio = 0.0001obtained abs = 4.20191e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16442; expected ratio = 0.001obtained abs = 51.4919; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.612560e+05 Mflops = 345.96 -Solve time = 0.00 -Solve flops = 1.536600e+04 Mflops = 495.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000270836; expected ratio = 0.0001obtained abs = 3.57451e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0997248; expected ratio = 0.001obtained abs = 29.9713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618560e+05 Mflops = 345.83 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 481.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000229213; expected ratio = 0.0001obtained abs = 3.02514e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0545762; expected ratio = 0.001obtained abs = 16.4152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.622400e+05 Mflops = 345.25 -Solve time = 0.00 -Solve flops = 1.541400e+04 Mflops = 497.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000583078; expected ratio = 0.0001obtained abs = 7.69557e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.14862; expected ratio = 0.001obtained abs = 44.5464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.608480e+05 Mflops = 343.68 -Solve time = 0.00 -Solve flops = 1.534200e+04 Mflops = 494.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000481518; expected ratio = 0.0001obtained abs = 6.35526e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.124785; expected ratio = 0.001obtained abs = 38.5849; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618560e+05 Mflops = 345.83 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 496.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00026774; expected ratio = 0.0001obtained abs = 3.53365e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0693867; expected ratio = 0.001obtained abs = 21.015; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.614480e+05 Mflops = 344.96 -Solve time = 0.00 -Solve flops = 1.536600e+04 Mflops = 480.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000180837; expected ratio = 0.0001obtained abs = 2.38666e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0495864; expected ratio = 0.001obtained abs = 14.8038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.620240e+05 Mflops = 345.49 -Solve time = 0.00 -Solve flops = 1.539600e+04 Mflops = 481.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00196584; expected ratio = 0.0001obtained abs = 2.59453e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109395; expected ratio = 0.001obtained abs = 32.9409; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.617280e+05 Mflops = 345.56 -Solve time = 0.00 -Solve flops = 1.538200e+04 Mflops = 496.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00184631; expected ratio = 0.0001obtained abs = 2.4368e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.141728; expected ratio = 0.001obtained abs = 44.0635; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.612560e+05 Mflops = 343.68 -Solve time = 0.00 -Solve flops = 1.536600e+04 Mflops = 495.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000310872; expected ratio = 0.0001obtained abs = 4.10287e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0824119; expected ratio = 0.001obtained abs = 24.8624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000413179 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.612560e+05 Mflops = 344.55 -Solve time = 0.00 -Solve flops = 1.536600e+04 Mflops = 480.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000164722; expected ratio = 0.0001obtained abs = 2.17398e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0451257; expected ratio = 0.001obtained abs = 13.5078; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.614480e+05 Mflops = 344.96 -Solve time = 0.00 -Solve flops = 1.536600e+04 Mflops = 495.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000176213; expected ratio = 0.0001obtained abs = 2.32565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0301554; expected ratio = 0.001obtained abs = 9.01962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.612560e+05 Mflops = 344.55 -Solve time = 0.00 -Solve flops = 1.536600e+04 Mflops = 480.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000283198; expected ratio = 0.0001obtained abs = 3.73768e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0527674; expected ratio = 0.001obtained abs = 15.7965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.614480e+05 Mflops = 345.67 -Solve time = 0.00 -Solve flops = 1.536600e+04 Mflops = 480.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00018805; expected ratio = 0.0001obtained abs = 2.48192e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0315619; expected ratio = 0.001obtained abs = 9.41538; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.608480e+05 Mflops = 343.68 -Solve time = 0.00 -Solve flops = 1.534200e+04 Mflops = 494.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00010676; expected ratio = 0.0001obtained abs = 1.40904e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0336329; expected ratio = 0.001obtained abs = 10.0053; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.608480e+05 Mflops = 344.56 -Solve time = 0.00 -Solve flops = 1.534200e+04 Mflops = 476.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000176887; expected ratio = 0.0001obtained abs = 2.33458e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0434505; expected ratio = 0.001obtained abs = 13.0731; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.7892 - Final Residual ratio : 0.0146037 - Residual ratio : 0.000924915 - Slope : -0.563379 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.7211 - Final Residual ratio : 0.00841689 - Residual ratio : 0.000571757 - Slope : -0.474602 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.0974 - Final Residual ratio : 0.0101348 - Residual ratio : 0.000718912 - Slope : -0.440226 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.654 - Final Residual ratio : 0.00856607 - Residual ratio : 0.000676947 - Slope : -0.421514 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 4.0301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1836 - Final Residual ratio : 0.0073054 - Residual ratio : 0.000717373 - Slope : -0.339208 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.98643 - Final Residual ratio : 0.00538358 - Residual ratio : 0.000674091 - Slope : -0.257453 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.5252 - Final Residual ratio : 0.00528293 - Residual ratio : 0.000702032 - Slope : -0.234997 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.08335 - Final Residual ratio : 0.00720155 - Residual ratio : 0.000890911 - Slope : -0.25238 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.90159 - Final Residual ratio : 0.00578994 - Residual ratio : 0.000732756 - Slope : -0.246744 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.64059 - Final Residual ratio : 0.00593744 - Residual ratio : 0.000894114 - Slope : -0.236952 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 110 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 110 - - Mesh vertices: 109 - Mesh triangles: 110 - Mesh edges: 182 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0351 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.608480e+05 Mflops = 341.59 -Solve time = 0.00 -Solve flops = 1.534200e+04 Mflops = 466.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0934363; expected ratio = 0.0001obtained abs = 0.00122349; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.215052; expected ratio = 0.001obtained abs = 68.8703; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618560e+05 Mflops = 345.13 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 496.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00901124; expected ratio = 0.0001obtained abs = 0.000118086; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0279543; expected ratio = 0.001obtained abs = 8.98171; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000408173 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618560e+05 Mflops = 345.83 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 481.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129719; expected ratio = 0.0001obtained abs = 1.69955e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142356; expected ratio = 0.001obtained abs = 4.57547; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618560e+05 Mflops = 346.54 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 481.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000166607; expected ratio = 0.0001obtained abs = 2.18284e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119138; expected ratio = 0.001obtained abs = 3.81969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618560e+05 Mflops = 345.83 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 481.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.13878e-05; expected ratio = 0.0001obtained abs = 4.11233e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00539178; expected ratio = 0.001obtained abs = 1.72847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0361 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.08955 - Final Residual ratio : 0.00333367 - Residual ratio : 0.000655004 - Slope : -0.211925 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.12898 - Final Residual ratio : 0.0032422 - Residual ratio : 0.000632135 - Slope : -0.183062 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.21486 - Final Residual ratio : 0.00519873 - Residual ratio : 0.0008365 - Slope : -0.194052 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.72505 - Final Residual ratio : 0.00495621 - Residual ratio : 0.000736977 - Slope : -0.210003 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.11807 - Final Residual ratio : 0.00542127 - Residual ratio : 0.000886107 - Slope : -0.197182 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.84743 - Final Residual ratio : 0.00384796 - Residual ratio : 0.000793815 - Slope : -0.16702 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.89372 - Final Residual ratio : 0.00286901 - Residual ratio : 0.000736829 - Slope : -0.134167 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.91013 - Final Residual ratio : 0.00247995 - Residual ratio : 0.000634237 - Slope : -0.122114 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.09775 - Final Residual ratio : 0.00246252 - Residual ratio : 0.000600945 - Slope : -0.127978 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.77133 - Final Residual ratio : 0.00289041 - Residual ratio : 0.000766416 - Slope : -0.125615 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 110 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 110 - - Mesh vertices: 109 - Mesh triangles: 110 - Mesh edges: 182 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0451 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618560e+05 Mflops = 342.87 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 481.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0905074; expected ratio = 0.0001obtained abs = 0.00118356; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0534762; expected ratio = 0.001obtained abs = 17.5823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618560e+05 Mflops = 336.58 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 481.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00852496; expected ratio = 0.0001obtained abs = 0.00011145; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0383553; expected ratio = 0.001obtained abs = 12.7289; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618560e+05 Mflops = 345.83 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 481.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00135208; expected ratio = 0.0001obtained abs = 1.76731e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0313699; expected ratio = 0.001obtained abs = 10.3337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.608480e+05 Mflops = 345.26 -Solve time = 0.00 -Solve flops = 1.534200e+04 Mflops = 480.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000122792; expected ratio = 0.0001obtained abs = 1.60499e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0173101; expected ratio = 0.001obtained abs = 5.71989; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.608480e+05 Mflops = 344.38 -Solve time = 0.00 -Solve flops = 1.534200e+04 Mflops = 480.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.33861e-05; expected ratio = 0.0001obtained abs = 9.59217e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.015551; expected ratio = 0.001obtained abs = 5.13197; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.81705 - Final Residual ratio : 0.00223541 - Residual ratio : 0.000793527 - Slope : -0.0938273 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.44873 - Final Residual ratio : 0.00236047 - Residual ratio : 0.000963959 - Slope : -0.0815456 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.15205 - Final Residual ratio : 0.00282684 - Residual ratio : 0.000896825 - Slope : -0.101588 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.90277 - Final Residual ratio : 0.00305084 - Residual ratio : 0.000781711 - Slope : -0.121866 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.05258 - Final Residual ratio : 0.00313852 - Residual ratio : 0.00077445 - Slope : -0.126545 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.56617 - Final Residual ratio : 0.00275507 - Residual ratio : 0.000772558 - Slope : -0.114949 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.83352 - Final Residual ratio : 0.00119001 - Residual ratio : 0.000419976 - Slope : -0.104901 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0531 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.43525 - Final Residual ratio : 0.00158854 - Residual ratio : 0.00065231 - Slope : -0.0839193 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.48378 - Final Residual ratio : 0.00161393 - Residual ratio : 0.000649787 - Slope : -0.0775677 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.56594 - Final Residual ratio : 0.00200019 - Residual ratio : 0.000779516 - Slope : -0.0827076 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 110 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 110 - - Mesh vertices: 109 - Mesh triangles: 110 - Mesh edges: 182 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0551 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.584340e+05 Mflops = 365.93 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 472.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0825336; expected ratio = 0.0001obtained abs = 0.00108091; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0391021; expected ratio = 0.001obtained abs = 12.5621; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.584340e+05 Mflops = 367.54 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 487.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00806127; expected ratio = 0.0001obtained abs = 0.000105538; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0203538; expected ratio = 0.001obtained abs = 6.57216; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.584460e+05 Mflops = 368.39 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 487.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00123205; expected ratio = 0.0001obtained abs = 1.61276e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.028358; expected ratio = 0.001obtained abs = 9.16338; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.584340e+05 Mflops = 366.73 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 487.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000199786; expected ratio = 0.0001obtained abs = 2.61518e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0473191; expected ratio = 0.001obtained abs = 15.2506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.585060e+05 Mflops = 368.53 -Solve time = 0.00 -Solve flops = 1.511200e+04 Mflops = 473.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00020607; expected ratio = 0.0001obtained abs = 2.69743e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.065928; expected ratio = 0.001obtained abs = 21.4542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.584340e+05 Mflops = 367.54 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 487.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000159079; expected ratio = 0.0001obtained abs = 2.08231e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0683965; expected ratio = 0.001obtained abs = 22.0086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.584460e+05 Mflops = 367.78 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 487.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000181437; expected ratio = 0.0001obtained abs = 2.37503e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0676635; expected ratio = 0.001obtained abs = 21.9819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.584340e+05 Mflops = 367.75 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 469.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000171693; expected ratio = 0.0001obtained abs = 2.24745e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0653818; expected ratio = 0.001obtained abs = 21.0038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.584460e+05 Mflops = 366.76 -Solve time = 0.00 -Solve flops = 1.510800e+04 Mflops = 487.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.05648e-05; expected ratio = 0.0001obtained abs = 1.05459e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0519561; expected ratio = 0.001obtained abs = 16.8205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.18624 - Final Residual ratio : 0.00136877 - Residual ratio : 0.000626084 - Slope : -0.0682771 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.78519 - Final Residual ratio : 0.00122524 - Residual ratio : 0.000686337 - Slope : -0.0660728 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81769 - Final Residual ratio : 0.00150642 - Residual ratio : 0.000828754 - Slope : -0.0605396 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.25705 - Final Residual ratio : 0.00143792 - Residual ratio : 0.00063708 - Slope : -0.0777797 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0601 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.62492 - Final Residual ratio : 0.00221438 - Residual ratio : 0.000843598 - Slope : -0.0846034 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.58976 - Final Residual ratio : 0.00206589 - Residual ratio : 0.000797713 - Slope : -0.083474 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.2728 - Final Residual ratio : 0.00154231 - Residual ratio : 0.000678592 - Slope : -0.0783193 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.89234 - Final Residual ratio : 0.00155514 - Residual ratio : 0.000821808 - Slope : -0.111223 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.69974 - Final Residual ratio : 0.000965836 - Residual ratio : 0.000568226 - Slope : -0.0585784 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76679 - Final Residual ratio : 0.00166468 - Residual ratio : 0.000942203 - Slope : -0.0588376 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 9 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 110 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 111 - - Mesh vertices: 109 - Mesh triangles: 111 - Mesh edges: 183 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0651 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000431776 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.709200e+05 Mflops = 352.45 -Solve time = 0.00 -Solve flops = 1.577000e+04 Mflops = 489.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0727083; expected ratio = 0.0001obtained abs = 0.000956556; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0989246; expected ratio = 0.001obtained abs = 34.4317; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.709200e+05 Mflops = 354.55 -Solve time = 0.00 -Solve flops = 1.577000e+04 Mflops = 493.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00696581; expected ratio = 0.0001obtained abs = 9.15419e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0635809; expected ratio = 0.001obtained abs = 21.9273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.708520e+05 Mflops = 351.62 -Solve time = 0.00 -Solve flops = 1.575800e+04 Mflops = 493.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00182768; expected ratio = 0.0001obtained abs = 2.40098e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130033; expected ratio = 0.001obtained abs = 45.532; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.710700e+05 Mflops = 355.03 -Solve time = 0.00 -Solve flops = 1.578000e+04 Mflops = 490.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00061783; expected ratio = 0.0001obtained abs = 8.11661e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.18777; expected ratio = 0.001obtained abs = 68.8716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.710700e+05 Mflops = 354.16 -Solve time = 0.00 -Solve flops = 1.578000e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000263032; expected ratio = 0.0001obtained abs = 3.4553e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.151948; expected ratio = 0.001obtained abs = 52.9325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.709200e+05 Mflops = 354.55 -Solve time = 0.00 -Solve flops = 1.577000e+04 Mflops = 493.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000206211; expected ratio = 0.0001obtained abs = 2.70884e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0650706; expected ratio = 0.001obtained abs = 22.7071; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.710700e+05 Mflops = 348.99 -Solve time = 0.00 -Solve flops = 1.578000e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000310787; expected ratio = 0.0001obtained abs = 4.08271e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.086524; expected ratio = 0.001obtained abs = 30.6983; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.710700e+05 Mflops = 354.86 -Solve time = 0.00 -Solve flops = 1.578000e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000365705; expected ratio = 0.0001obtained abs = 4.80422e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0840967; expected ratio = 0.001obtained abs = 29.8404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.710700e+05 Mflops = 354.86 -Solve time = 0.00 -Solve flops = 1.578000e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000188826; expected ratio = 0.0001obtained abs = 2.48049e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0588409; expected ratio = 0.001obtained abs = 20.5769; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.717120e+05 Mflops = 353.39 -Solve time = 0.00 -Solve flops = 1.581800e+04 Mflops = 495.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000461127; expected ratio = 0.0001obtained abs = 6.05754e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.136257; expected ratio = 0.001obtained abs = 47.9822; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.710700e+05 Mflops = 354.86 -Solve time = 0.00 -Solve flops = 1.578000e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00048359; expected ratio = 0.0001obtained abs = 6.35282e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130909; expected ratio = 0.001obtained abs = 46.9857; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.710700e+05 Mflops = 354.86 -Solve time = 0.00 -Solve flops = 1.578000e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000158493; expected ratio = 0.0001obtained abs = 2.082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0972666; expected ratio = 0.001obtained abs = 33.8207; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.717120e+05 Mflops = 344.76 -Solve time = 0.00 -Solve flops = 1.581800e+04 Mflops = 495.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000688249; expected ratio = 0.0001obtained abs = 9.04119e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.161198; expected ratio = 0.001obtained abs = 56.7719; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.709200e+05 Mflops = 353.85 -Solve time = 0.00 -Solve flops = 1.577000e+04 Mflops = 493.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000473006; expected ratio = 0.0001obtained abs = 6.21397e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.125509; expected ratio = 0.001obtained abs = 44.8446; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.709200e+05 Mflops = 349.53 -Solve time = 0.00 -Solve flops = 1.577000e+04 Mflops = 475.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000372865; expected ratio = 0.0001obtained abs = 4.89819e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0431748; expected ratio = 0.001obtained abs = 15.2337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.709200e+05 Mflops = 353.15 -Solve time = 0.00 -Solve flops = 1.577000e+04 Mflops = 493.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000191665; expected ratio = 0.0001obtained abs = 2.51775e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0611619; expected ratio = 0.001obtained abs = 21.3552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.717120e+05 Mflops = 354.78 -Solve time = 0.00 -Solve flops = 1.581800e+04 Mflops = 477.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000247624; expected ratio = 0.0001obtained abs = 3.2529e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.098252; expected ratio = 0.001obtained abs = 33.974; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.709200e+05 Mflops = 353.85 -Solve time = 0.00 -Solve flops = 1.577000e+04 Mflops = 493.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000103027; expected ratio = 0.0001obtained abs = 1.35344e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0693788; expected ratio = 0.001obtained abs = 24.4533; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.710700e+05 Mflops = 354.86 -Solve time = 0.00 -Solve flops = 1.578000e+04 Mflops = 493.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000313566; expected ratio = 0.0001obtained abs = 4.11921e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0386026; expected ratio = 0.001obtained abs = 13.6467; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.709200e+05 Mflops = 353.85 -Solve time = 0.00 -Solve flops = 1.577000e+04 Mflops = 493.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000113709; expected ratio = 0.0001obtained abs = 1.49371e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0598384; expected ratio = 0.001obtained abs = 20.8626; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.68592 - Final Residual ratio : 0.00116615 - Residual ratio : 0.000691704 - Slope : -0.0543468 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.90421 - Final Residual ratio : 0.00181787 - Residual ratio : 0.000954656 - Slope : -0.0634132 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03717 - Final Residual ratio : 0.00142975 - Residual ratio : 0.00070183 - Slope : -0.0753979 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.09178 - Final Residual ratio : 0.0019034 - Residual ratio : 0.000909939 - Slope : -0.0696627 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.14199 - Final Residual ratio : 0.00203491 - Residual ratio : 0.000950007 - Slope : -0.0713319 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.01625 - Final Residual ratio : 0.00178599 - Residual ratio : 0.000885799 - Slope : -0.0671488 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83582 - Final Residual ratio : 0.00153857 - Residual ratio : 0.000838082 - Slope : -0.0632511 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61854 - Final Residual ratio : 0.00146966 - Residual ratio : 0.000908018 - Slope : -0.0646829 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.45052 - Final Residual ratio : 0.00138427 - Residual ratio : 0.00095433 - Slope : -0.0483044 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.44038 - Final Residual ratio : 0.0013697 - Residual ratio : 0.000950926 - Slope : -0.0496212 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 111 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 111 - - Mesh vertices: 110 - Mesh triangles: 113 - Mesh edges: 186 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0751 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.707440e+05 Mflops = 366.51 -Solve time = 0.00 -Solve flops = 1.544000e+04 Mflops = 465.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0662547; expected ratio = 0.0001obtained abs = 0.000870149; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.166751; expected ratio = 0.001obtained abs = 56.3884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000414848 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.704820e+05 Mflops = 378.74 -Solve time = 0.00 -Solve flops = 1.542600e+04 Mflops = 497.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00649655; expected ratio = 0.0001obtained abs = 8.53058e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.152584; expected ratio = 0.001obtained abs = 52.784; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.712740e+05 Mflops = 378.89 -Solve time = 0.00 -Solve flops = 1.547400e+04 Mflops = 484.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117122; expected ratio = 0.0001obtained abs = 1.5377e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0927755; expected ratio = 0.001obtained abs = 31.2017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.706320e+05 Mflops = 378.27 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 498.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000462028; expected ratio = 0.0001obtained abs = 6.06589e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0981403; expected ratio = 0.001obtained abs = 33.84; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000404835 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.706320e+05 Mflops = 380.08 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 479.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000410187; expected ratio = 0.0001obtained abs = 5.38541e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.086414; expected ratio = 0.001obtained abs = 30.0047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.706320e+05 Mflops = 379.27 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 483.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000222314; expected ratio = 0.0001obtained abs = 2.91871e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0943643; expected ratio = 0.001obtained abs = 32.2046; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.714240e+05 Mflops = 380.02 -Solve time = 0.00 -Solve flops = 1.548400e+04 Mflops = 484.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000621741; expected ratio = 0.0001obtained abs = 8.16271e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.174755; expected ratio = 0.001obtained abs = 59.5695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.704820e+05 Mflops = 379.74 -Solve time = 0.00 -Solve flops = 1.542600e+04 Mflops = 497.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000426407; expected ratio = 0.0001obtained abs = 5.59843e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.164925; expected ratio = 0.001obtained abs = 57.0866; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.712740e+05 Mflops = 369.15 -Solve time = 0.00 -Solve flops = 1.547400e+04 Mflops = 484.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000136959; expected ratio = 0.0001obtained abs = 1.79814e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110316; expected ratio = 0.001obtained abs = 37.2636; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.706320e+05 Mflops = 379.07 -Solve time = 0.00 -Solve flops = 1.543600e+04 Mflops = 483.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.46339e-05; expected ratio = 0.0001obtained abs = 1.11115e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108791; expected ratio = 0.001obtained abs = 37.5182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.2164 - Final Residual ratio : 0.0111712 - Residual ratio : 0.000845256 - Slope : -0.455352 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.0582 - Final Residual ratio : 0.0195792 - Residual ratio : 0.000723596 - Slope : -0.932366 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.6622 - Final Residual ratio : 0.0254281 - Residual ratio : 0.000919235 - Slope : -0.952993 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.4806 - Final Residual ratio : 0.00947756 - Residual ratio : 0.000403634 - Slope : -0.782369 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.5706 - Final Residual ratio : 0.0169828 - Residual ratio : 0.000966544 - Slope : -0.566247 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.682 - Final Residual ratio : 0.00970001 - Residual ratio : 0.000764862 - Slope : -0.408785 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.4483 - Final Residual ratio : 0.00705374 - Residual ratio : 0.000616141 - Slope : -0.369071 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.5722 - Final Residual ratio : 0.0110698 - Residual ratio : 0.000880502 - Slope : -0.433141 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.9397 - Final Residual ratio : 0.00953261 - Residual ratio : 0.000736693 - Slope : -0.445869 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 90.8001 - Final Residual ratio : 0.0754135 - Residual ratio : 0.000830545 - Slope : -3.12844 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 113 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 113 - - Mesh vertices: 110 - Mesh triangles: 113 - Mesh edges: 186 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0851 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.236480e+05 Mflops = 318.76 -Solve time = 0.00 -Solve flops = 1.376200e+04 Mflops = 444.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0634312; expected ratio = 0.0001obtained abs = 0.000840873; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.10986; expected ratio = 0.001obtained abs = 38.1447; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.228560e+05 Mflops = 319.86 -Solve time = 0.00 -Solve flops = 1.371400e+04 Mflops = 456.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00614516; expected ratio = 0.0001obtained abs = 8.13323e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.089328; expected ratio = 0.001obtained abs = 31.6624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.223760e+05 Mflops = 319.40 -Solve time = 0.00 -Solve flops = 1.368000e+04 Mflops = 441.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00125586; expected ratio = 0.0001obtained abs = 1.662e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0890129; expected ratio = 0.001obtained abs = 31.7319; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.230180e+05 Mflops = 318.70 -Solve time = 0.00 -Solve flops = 1.371800e+04 Mflops = 456.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000427406; expected ratio = 0.0001obtained abs = 5.65615e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138422; expected ratio = 0.001obtained abs = 48.6509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.223760e+05 Mflops = 318.81 -Solve time = 0.00 -Solve flops = 1.368000e+04 Mflops = 455.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000417915; expected ratio = 0.0001obtained abs = 5.53076e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.171726; expected ratio = 0.001obtained abs = 62.5; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000405788 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.230180e+05 Mflops = 319.49 -Solve time = 0.00 -Solve flops = 1.371800e+04 Mflops = 442.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000212862; expected ratio = 0.0001obtained abs = 2.81695e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.147658; expected ratio = 0.001obtained abs = 51.4996; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.222260e+05 Mflops = 319.01 -Solve time = 0.00 -Solve flops = 1.367000e+04 Mflops = 441.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000134378; expected ratio = 0.0001obtained abs = 1.77833e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.095287; expected ratio = 0.001obtained abs = 33.8827; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.222260e+05 Mflops = 319.21 -Solve time = 0.00 -Solve flops = 1.367000e+04 Mflops = 455.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000103858; expected ratio = 0.0001obtained abs = 1.37445e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0828597; expected ratio = 0.001obtained abs = 28.8473; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.223760e+05 Mflops = 319.40 -Solve time = 0.00 -Solve flops = 1.368000e+04 Mflops = 459.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000402344; expected ratio = 0.0001obtained abs = 5.32461e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0973572; expected ratio = 0.001obtained abs = 34.6841; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.223760e+05 Mflops = 319.60 -Solve time = 0.00 -Solve flops = 1.368000e+04 Mflops = 455.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000643729; expected ratio = 0.0001obtained abs = 8.51936e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.156757; expected ratio = 0.001obtained abs = 58.6526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000404835 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.223760e+05 Mflops = 312.22 -Solve time = 0.00 -Solve flops = 1.368000e+04 Mflops = 455.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000351105; expected ratio = 0.0001obtained abs = 4.64634e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.179296; expected ratio = 0.001obtained abs = 63.4115; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.223760e+05 Mflops = 318.61 -Solve time = 0.00 -Solve flops = 1.368000e+04 Mflops = 459.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000203553; expected ratio = 0.0001obtained abs = 2.69366e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.140825; expected ratio = 0.001obtained abs = 48.9391; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.223760e+05 Mflops = 317.82 -Solve time = 0.00 -Solve flops = 1.368000e+04 Mflops = 459.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000574002; expected ratio = 0.0001obtained abs = 7.59605e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138247; expected ratio = 0.001obtained abs = 49.7359; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000403166 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.223760e+05 Mflops = 319.60 -Solve time = 0.00 -Solve flops = 1.368000e+04 Mflops = 455.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000585902; expected ratio = 0.0001obtained abs = 7.75393e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120667; expected ratio = 0.001obtained abs = 44.677; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.223760e+05 Mflops = 318.61 -Solve time = 0.00 -Solve flops = 1.368000e+04 Mflops = 455.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000336762; expected ratio = 0.0001obtained abs = 4.4565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.18199; expected ratio = 0.001obtained abs = 64.0405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.230180e+05 Mflops = 319.49 -Solve time = 0.00 -Solve flops = 1.371800e+04 Mflops = 334.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00077047; expected ratio = 0.0001obtained abs = 1.01958e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.181173; expected ratio = 0.001obtained abs = 64.2684; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.221840e+05 Mflops = 318.90 -Solve time = 0.00 -Solve flops = 1.366600e+04 Mflops = 458.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000526467; expected ratio = 0.0001obtained abs = 6.96742e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.154913; expected ratio = 0.001obtained abs = 54.7246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.226820e+05 Mflops = 317.83 -Solve time = 0.00 -Solve flops = 1.369400e+04 Mflops = 455.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000492925; expected ratio = 0.0001obtained abs = 6.52336e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.168453; expected ratio = 0.001obtained abs = 59.4837; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.218480e+05 Mflops = 318.03 -Solve time = 0.00 -Solve flops = 1.364200e+04 Mflops = 457.75 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000376173; expected ratio = 0.0001obtained abs = 4.97843e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1501; expected ratio = 0.001obtained abs = 53.2895; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.222260e+05 Mflops = 319.01 -Solve time = 0.00 -Solve flops = 1.367000e+04 Mflops = 441.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00027327; expected ratio = 0.0001obtained abs = 3.61644e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0759733; expected ratio = 0.001obtained abs = 26.7483; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.5537 - Final Residual ratio : 0.0175404 - Residual ratio : 0.000897037 - Slope : -0.630197 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.2893 - Final Residual ratio : 0.0175899 - Residual ratio : 0.0009119 - Slope : -0.642391 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.3361 - Final Residual ratio : 0.0131904 - Residual ratio : 0.000719368 - Slope : -0.572592 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.857 - Final Residual ratio : 0.0167282 - Residual ratio : 0.00099236 - Slope : -0.526257 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.4711 - Final Residual ratio : 0.013562 - Residual ratio : 0.000937178 - Slope : -0.516342 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0602 - Final Residual ratio : 0.00759169 - Residual ratio : 0.000629484 - Slope : -0.36523 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1091 - Final Residual ratio : 0.00785537 - Residual ratio : 0.000777057 - Slope : -0.315665 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.07514 - Final Residual ratio : 0.00849773 - Residual ratio : 0.000936374 - Slope : -0.302221 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.57812 - Final Residual ratio : 0.00738046 - Residual ratio : 0.000860382 - Slope : -0.276476 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.9916 - Final Residual ratio : 0.00647024 - Residual ratio : 0.00080963 - Slope : -0.266171 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.0951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 113 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 111 - - Mesh vertices: 109 - Mesh triangles: 111 - Mesh edges: 183 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.0951 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.482740e+05 Mflops = 341.52 -Solve time = 0.00 -Solve flops = 1.450000e+04 Mflops = 467.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0613963; expected ratio = 0.0001obtained abs = 0.000826727; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.127731; expected ratio = 0.001obtained abs = 43.9657; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.491440e+05 Mflops = 343.71 -Solve time = 0.00 -Solve flops = 1.455400e+04 Mflops = 469.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0101811; expected ratio = 0.0001obtained abs = 0.00013719; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109338; expected ratio = 0.001obtained abs = 37.3199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.499360e+05 Mflops = 345.54 -Solve time = 0.00 -Solve flops = 1.460200e+04 Mflops = 471.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00200325; expected ratio = 0.0001obtained abs = 2.69892e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.090717; expected ratio = 0.001obtained abs = 30.4415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.492940e+05 Mflops = 344.82 -Solve time = 0.00 -Solve flops = 1.456400e+04 Mflops = 469.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000407941; expected ratio = 0.0001obtained abs = 5.49604e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.123883; expected ratio = 0.001obtained abs = 42.8755; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.492940e+05 Mflops = 346.34 -Solve time = 0.00 -Solve flops = 1.456400e+04 Mflops = 469.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000413969; expected ratio = 0.0001obtained abs = 5.57739e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.112291; expected ratio = 0.001obtained abs = 39.3201; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000419855 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.485040e+05 Mflops = 343.75 -Solve time = 0.00 -Solve flops = 1.451400e+04 Mflops = 468.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000229813; expected ratio = 0.0001obtained abs = 3.09616e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0968352; expected ratio = 0.001obtained abs = 33.0023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.495960e+05 Mflops = 336.07 -Solve time = 0.00 -Solve flops = 1.458200e+04 Mflops = 470.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00044126; expected ratio = 0.0001obtained abs = 5.94487e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.162342; expected ratio = 0.001obtained abs = 55.7708; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.489540e+05 Mflops = 344.79 -Solve time = 0.00 -Solve flops = 1.454400e+04 Mflops = 469.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000443818; expected ratio = 0.0001obtained abs = 5.97949e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.133096; expected ratio = 0.001obtained abs = 46.5771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.488040e+05 Mflops = 345.40 -Solve time = 0.00 -Solve flops = 1.453400e+04 Mflops = 468.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000179415; expected ratio = 0.0001obtained abs = 2.41716e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116223; expected ratio = 0.001obtained abs = 39.2504; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000419855 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.495960e+05 Mflops = 343.81 -Solve time = 0.00 -Solve flops = 1.458200e+04 Mflops = 470.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000674366; expected ratio = 0.0001obtained abs = 9.08544e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.179652; expected ratio = 0.001obtained abs = 61.9088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.491440e+05 Mflops = 346.76 -Solve time = 0.00 -Solve flops = 1.455400e+04 Mflops = 484.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000484709; expected ratio = 0.0001obtained abs = 6.53051e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.146971; expected ratio = 0.001obtained abs = 51.234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.488040e+05 Mflops = 344.44 -Solve time = 0.00 -Solve flops = 1.453400e+04 Mflops = 468.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000314445; expected ratio = 0.0001obtained abs = 4.23642e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0535146; expected ratio = 0.001obtained abs = 18.2707; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.00043416 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.488040e+05 Mflops = 344.44 -Solve time = 0.00 -Solve flops = 1.453400e+04 Mflops = 483.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000150391; expected ratio = 0.0001obtained abs = 2.02613e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0508356; expected ratio = 0.001obtained abs = 17.2228; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.496000e+05 Mflops = 344.57 -Solve time = 0.00 -Solve flops = 1.457800e+04 Mflops = 485.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000458353; expected ratio = 0.0001obtained abs = 6.17521e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159439; expected ratio = 0.001obtained abs = 54.6775; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.491440e+05 Mflops = 345.23 -Solve time = 0.00 -Solve flops = 1.455400e+04 Mflops = 469.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000390542; expected ratio = 0.0001obtained abs = 5.26176e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.169285; expected ratio = 0.001obtained abs = 59.3444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.488040e+05 Mflops = 344.44 -Solve time = 0.00 -Solve flops = 1.453400e+04 Mflops = 483.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000235403; expected ratio = 0.0001obtained abs = 3.17149e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0831103; expected ratio = 0.001obtained abs = 28.2362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.488040e+05 Mflops = 344.44 -Solve time = 0.00 -Solve flops = 1.453400e+04 Mflops = 483.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000120475; expected ratio = 0.0001obtained abs = 1.62309e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0447673; expected ratio = 0.001obtained abs = 15.1425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.498900e+05 Mflops = 344.67 -Solve time = 0.00 -Solve flops = 1.459800e+04 Mflops = 470.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00045464; expected ratio = 0.0001obtained abs = 6.1252e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.154382; expected ratio = 0.001obtained abs = 52.9498; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000418186 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.491440e+05 Mflops = 345.99 -Solve time = 0.00 -Solve flops = 1.455400e+04 Mflops = 484.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000402063; expected ratio = 0.0001obtained abs = 5.417e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.169637; expected ratio = 0.001obtained abs = 59.4882; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.488040e+05 Mflops = 343.68 -Solve time = 0.00 -Solve flops = 1.453400e+04 Mflops = 483.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000243666; expected ratio = 0.0001obtained abs = 3.28282e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0834858; expected ratio = 0.001obtained abs = 28.3887; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.0961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.31706 - Final Residual ratio : 0.00414522 - Residual ratio : 0.000566515 - Slope : -0.243764 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.63369 - Final Residual ratio : 0.00638841 - Residual ratio : 0.000963024 - Slope : -0.288144 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.18458 - Final Residual ratio : 0.00475412 - Residual ratio : 0.000768705 - Slope : -0.199349 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.0991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.88895 - Final Residual ratio : 0.00495317 - Residual ratio : 0.000841096 - Slope : -0.189806 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.0991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.42091 - Final Residual ratio : 0.00385199 - Residual ratio : 0.000710579 - Slope : -0.174744 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.98435 - Final Residual ratio : 0.00423338 - Residual ratio : 0.000849336 - Slope : -0.160649 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.50749 - Final Residual ratio : 0.00339406 - Residual ratio : 0.000752981 - Slope : -0.140753 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.25391 - Final Residual ratio : 0.0030914 - Residual ratio : 0.000726718 - Slope : -0.132838 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.19073 - Final Residual ratio : 0.00375442 - Residual ratio : 0.000895886 - Slope : -0.144379 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.09066 - Final Residual ratio : 0.00387827 - Residual ratio : 0.000948081 - Slope : -0.136226 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 111 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 110 - - Mesh vertices: 109 - Mesh triangles: 110 - Mesh edges: 182 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1051 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.481840e+05 Mflops = 341.50 -Solve time = 0.00 -Solve flops = 1.451400e+04 Mflops = 468.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0582; expected ratio = 0.0001obtained abs = 0.000792796; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0695867; expected ratio = 0.001obtained abs = 23.8862; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.491440e+05 Mflops = 343.71 -Solve time = 0.00 -Solve flops = 1.457400e+04 Mflops = 485.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00601054; expected ratio = 0.0001obtained abs = 8.17865e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.05445; expected ratio = 0.001obtained abs = 18.7763; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.486480e+05 Mflops = 342.57 -Solve time = 0.00 -Solve flops = 1.454600e+04 Mflops = 469.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00124891; expected ratio = 0.0001obtained abs = 1.69955e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11465; expected ratio = 0.001obtained abs = 40.6176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.492940e+05 Mflops = 344.06 -Solve time = 0.00 -Solve flops = 1.458400e+04 Mflops = 489.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000400562; expected ratio = 0.0001obtained abs = 5.45085e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0929171; expected ratio = 0.001obtained abs = 33.0911; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.489940e+05 Mflops = 345.07 -Solve time = 0.00 -Solve flops = 1.456400e+04 Mflops = 466.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.14485e-05; expected ratio = 0.0001obtained abs = 1.24443e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138661; expected ratio = 0.001obtained abs = 48.1728; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.4382 - Final Residual ratio : 0.0132954 - Residual ratio : 0.000920845 - Slope : -0.534256 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.82164 - Final Residual ratio : 0.00700351 - Residual ratio : 0.00071307 - Slope : -0.363505 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.6504 - Final Residual ratio : 0.0122902 - Residual ratio : 0.000971525 - Slope : -0.451361 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.3503 - Final Residual ratio : 0.0351278 - Residual ratio : 0.000810325 - Slope : -1.66597 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.3452 - Final Residual ratio : 0.0174517 - Residual ratio : 0.000575107 - Slope : -1.01092 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.2063 - Final Residual ratio : 0.0143094 - Residual ratio : 0.000708165 - Slope : -0.673068 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.3838 - Final Residual ratio : 0.00525638 - Residual ratio : 0.00071188 - Slope : -0.238017 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0621 - Final Residual ratio : 0.009062 - Residual ratio : 0.000900607 - Slope : -0.335101 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.5988 - Final Residual ratio : 0.00887863 - Residual ratio : 0.000837701 - Slope : -0.352998 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1151 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.46733 - Final Residual ratio : 0.00815786 - Residual ratio : 0.000861685 - Slope : -0.315306 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 110 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 109 - - Mesh vertices: 108 - Mesh triangles: 109 - Mesh edges: 180 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1151 -matrix_partition : [5](0,44,88,132,178) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.468060e+05 Mflops = 343.80 -Solve time = 0.00 -Solve flops = 1.432200e+04 Mflops = 462.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.058066; expected ratio = 0.0001obtained abs = 0.000795115; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110973; expected ratio = 0.001obtained abs = 39.6408; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000392914 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.446300e+05 Mflops = 343.50 -Solve time = 0.00 -Solve flops = 1.418600e+04 Mflops = 472.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00649548; expected ratio = 0.0001obtained abs = 8.87944e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106408; expected ratio = 0.001obtained abs = 38.9651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000389814 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.443540e+05 Mflops = 343.82 -Solve time = 0.00 -Solve flops = 1.416600e+04 Mflops = 457.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00171823; expected ratio = 0.0001obtained abs = 2.34898e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0814021; expected ratio = 0.001obtained abs = 29.4845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000393867 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.443540e+05 Mflops = 343.82 -Solve time = 0.00 -Solve flops = 1.416600e+04 Mflops = 457.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000708168; expected ratio = 0.0001obtained abs = 9.68119e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0572425; expected ratio = 0.001obtained abs = 20.8579; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000394821 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.451000e+05 Mflops = 343.84 -Solve time = 0.00 -Solve flops = 1.421000e+04 Mflops = 458.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000473005; expected ratio = 0.0001obtained abs = 6.46639e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.178777; expected ratio = 0.001obtained abs = 66.2409; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000392914 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.442040e+05 Mflops = 343.46 -Solve time = 0.00 -Solve flops = 1.415600e+04 Mflops = 471.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000426168; expected ratio = 0.0001obtained abs = 5.82613e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19636; expected ratio = 0.001obtained abs = 76.4208; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.445040e+05 Mflops = 344.18 -Solve time = 0.00 -Solve flops = 1.417600e+04 Mflops = 471.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000237784; expected ratio = 0.0001obtained abs = 3.25066e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.143453; expected ratio = 0.001obtained abs = 52.514; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000418186 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.443540e+05 Mflops = 343.82 -Solve time = 0.00 -Solve flops = 1.416600e+04 Mflops = 471.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000157022; expected ratio = 0.0001obtained abs = 2.14658e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0581557; expected ratio = 0.001obtained abs = 21.1002; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.451000e+05 Mflops = 342.87 -Solve time = 0.00 -Solve flops = 1.421000e+04 Mflops = 476.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000458826; expected ratio = 0.0001obtained abs = 6.27253e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.181608; expected ratio = 0.001obtained abs = 67.4005; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.443540e+05 Mflops = 343.62 -Solve time = 0.00 -Solve flops = 1.416600e+04 Mflops = 471.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00036362; expected ratio = 0.0001obtained abs = 4.97106e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.193845; expected ratio = 0.001obtained abs = 73.2952; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000390053 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.443540e+05 Mflops = 338.06 -Solve time = 0.00 -Solve flops = 1.416600e+04 Mflops = 471.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000203656; expected ratio = 0.0001obtained abs = 2.78412e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100952; expected ratio = 0.001obtained abs = 36.8674; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,109) -time: 0.000393152 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.443540e+05 Mflops = 344.60 -Solve time = 0.00 -Solve flops = 1.416600e+04 Mflops = 457.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.98036e-05; expected ratio = 0.0001obtained abs = 1.22767e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0662905; expected ratio = 0.001obtained abs = 24.1293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.67339 - Final Residual ratio : 0.00650542 - Residual ratio : 0.000847789 - Slope : -0.264375 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.3678 - Final Residual ratio : 0.0335531 - Residual ratio : 0.000897913 - Slope : -1.96496 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 95.5002 - Final Residual ratio : 0.0862725 - Residual ratio : 0.000903375 - Slope : -8.67399 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 112.158 - Final Residual ratio : 0.0983876 - Residual ratio : 0.00087722 - Slope : -9.33834 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.0261 - Final Residual ratio : 0.0657151 - Residual ratio : 0.00099529 - Slope : -4.39736 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.5093 - Final Residual ratio : 0.0339008 - Residual ratio : 0.000779162 - Slope : -2.4153 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.9315 - Final Residual ratio : 0.0221747 - Residual ratio : 0.000793895 - Slope : -0.962391 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.4158 - Final Residual ratio : 0.0168334 - Residual ratio : 0.000914071 - Slope : -0.634448 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1241 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4884 - Final Residual ratio : 0.0126409 - Residual ratio : 0.000937169 - Slope : -0.481276 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 262.127 - Final Residual ratio : 0.211952 - Residual ratio : 0.000808583 - Slope : -9.03156 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 12 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 109 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 110 - - Mesh vertices: 108 - Mesh triangles: 110 - Mesh edges: 181 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1251 -matrix_partition : [5](0,44,88,132,178) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.260190e+05 Mflops = 329.12 -Solve time = 0.00 -Solve flops = 1.367000e+04 Mflops = 455.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.122871; expected ratio = 0.0001obtained abs = 0.00169264; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.273738; expected ratio = 0.001obtained abs = 111.87; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000404835 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.252330e+05 Mflops = 322.84 -Solve time = 0.00 -Solve flops = 1.361600e+04 Mflops = 453.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0102057; expected ratio = 0.0001obtained abs = 0.000140394; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.159659; expected ratio = 0.001obtained abs = 71.3554; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000414848 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.251910e+05 Mflops = 330.45 -Solve time = 0.00 -Solve flops = 1.361200e+04 Mflops = 453.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0128962; expected ratio = 0.0001obtained abs = 0.000177078; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.067139; expected ratio = 0.001obtained abs = 29.5278; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000408173 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.251910e+05 Mflops = 329.42 -Solve time = 0.00 -Solve flops = 1.361200e+04 Mflops = 471.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00390323; expected ratio = 0.0001obtained abs = 5.3581e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0767931; expected ratio = 0.001obtained abs = 33.3146; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 328.46 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 455.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00218369; expected ratio = 0.0001obtained abs = 2.99732e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110832; expected ratio = 0.001obtained abs = 46.6206; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248910e+05 Mflops = 328.63 -Solve time = 0.00 -Solve flops = 1.359200e+04 Mflops = 452.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00210753; expected ratio = 0.0001obtained abs = 2.8926e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0703581; expected ratio = 0.001obtained abs = 29.35; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.253410e+05 Mflops = 321.34 -Solve time = 0.00 -Solve flops = 1.362200e+04 Mflops = 453.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00196666; expected ratio = 0.0001obtained abs = 2.69929e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.064128; expected ratio = 0.001obtained abs = 27.0588; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.251910e+05 Mflops = 330.24 -Solve time = 0.00 -Solve flops = 1.361200e+04 Mflops = 471.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00198578; expected ratio = 0.0001obtained abs = 2.72546e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0473437; expected ratio = 0.001obtained abs = 19.6522; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000404835 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 329.49 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 467.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00193907; expected ratio = 0.0001obtained abs = 2.66136e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0518801; expected ratio = 0.001obtained abs = 21.422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.253410e+05 Mflops = 330.64 -Solve time = 0.00 -Solve flops = 1.362200e+04 Mflops = 472.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000964505; expected ratio = 0.0001obtained abs = 1.32366e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102744; expected ratio = 0.001obtained abs = 43.4308; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000404835 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 330.11 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 455.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00060964; expected ratio = 0.0001obtained abs = 8.36659e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0998797; expected ratio = 0.001obtained abs = 41.7099; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 329.49 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 452.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000320456; expected ratio = 0.0001obtained abs = 4.39768e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0677825; expected ratio = 0.001obtained abs = 28.1047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 328.46 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 470.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000110031; expected ratio = 0.0001obtained abs = 1.50998e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0671164; expected ratio = 0.001obtained abs = 27.6982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 329.28 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 452.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000540994; expected ratio = 0.0001obtained abs = 7.42447e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0769759; expected ratio = 0.001obtained abs = 32.1778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 329.49 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 452.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000636721; expected ratio = 0.0001obtained abs = 8.73823e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0668323; expected ratio = 0.001obtained abs = 27.7039; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 329.28 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 452.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000516531; expected ratio = 0.0001obtained abs = 7.08864e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0461382; expected ratio = 0.001obtained abs = 19.1859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 328.66 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 467.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000467257; expected ratio = 0.0001obtained abs = 6.41246e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0368874; expected ratio = 0.001obtained abs = 15.3116; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 329.28 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 470.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00170825; expected ratio = 0.0001obtained abs = 2.34454e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0313559; expected ratio = 0.001obtained abs = 13.0378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 323.39 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 452.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00194401; expected ratio = 0.0001obtained abs = 2.66814e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0255895; expected ratio = 0.001obtained abs = 10.6357; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.248270e+05 Mflops = 329.49 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 467.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000791318; expected ratio = 0.0001obtained abs = 1.08595e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0194383; expected ratio = 0.001obtained abs = 8.08748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.3541 - Final Residual ratio : 0.0302949 - Residual ratio : 0.000998049 - Slope : -1.1663 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.094 - Final Residual ratio : 0.0142161 - Residual ratio : 0.000883319 - Slope : -0.554476 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.3268 - Final Residual ratio : 0.0220006 - Residual ratio : 0.000904377 - Slope : -0.784025 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.884 - Final Residual ratio : 0.0222382 - Residual ratio : 0.00085915 - Slope : -0.83425 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 4.1301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.3824 - Final Residual ratio : 0.0177937 - Residual ratio : 0.000760987 - Slope : -0.753696 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.1646 - Final Residual ratio : 0.0164467 - Residual ratio : 0.000858177 - Slope : -0.638273 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.4549 - Final Residual ratio : 0.0117503 - Residual ratio : 0.000760294 - Slope : -0.532522 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.3625 - Final Residual ratio : 0.0124782 - Residual ratio : 0.000933822 - Slope : -0.494445 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.4278 - Final Residual ratio : 0.0088277 - Residual ratio : 0.000710318 - Slope : -0.413966 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.6597 - Final Residual ratio : 0.0098817 - Residual ratio : 0.00084751 - Slope : -0.388327 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 110 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 111 - - Mesh vertices: 108 - Mesh triangles: 111 - Mesh edges: 182 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1351 -matrix_partition : [5](0,44,88,132,178) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.250380e+05 Mflops = 314.98 -Solve time = 0.00 -Solve flops = 1.356800e+04 Mflops = 455.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0904441; expected ratio = 0.0001obtained abs = 0.00124121; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.642625; expected ratio = 0.001obtained abs = 179.945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.252600e+05 Mflops = 322.71 -Solve time = 0.00 -Solve flops = 1.360000e+04 Mflops = 471.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0295982; expected ratio = 0.0001obtained abs = 0.000408345; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0748046; expected ratio = 0.001obtained abs = 20.2716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258680e+05 Mflops = 323.68 -Solve time = 0.00 -Solve flops = 1.364200e+04 Mflops = 469.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00272744; expected ratio = 0.0001obtained abs = 3.76011e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.021693; expected ratio = 0.001obtained abs = 5.91568; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258680e+05 Mflops = 323.49 -Solve time = 0.00 -Solve flops = 1.364200e+04 Mflops = 469.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000266821; expected ratio = 0.0001obtained abs = 3.67876e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0124922; expected ratio = 0.001obtained abs = 3.40282; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258680e+05 Mflops = 314.06 -Solve time = 0.00 -Solve flops = 1.364200e+04 Mflops = 454.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.06647e-05; expected ratio = 0.0001obtained abs = 4.22782e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0110015; expected ratio = 0.001obtained abs = 3.00017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.3042 - Final Residual ratio : 0.0121227 - Residual ratio : 0.000985251 - Slope : -0.455261 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.1518 - Final Residual ratio : 0.0128093 - Residual ratio : 0.000793057 - Slope : -0.576394 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2417 - Final Residual ratio : 0.0113141 - Residual ratio : 0.000696605 - Slope : -0.705671 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.329 - Final Residual ratio : 0.0131826 - Residual ratio : 0.000919993 - Slope : -0.477195 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9806 - Final Residual ratio : 0.00874449 - Residual ratio : 0.000729886 - Slope : -0.630099 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.97874 - Final Residual ratio : 0.00776304 - Residual ratio : 0.000777958 - Slope : -0.332366 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.76639 - Final Residual ratio : 0.00677123 - Residual ratio : 0.000772408 - Slope : -0.312844 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.14537 - Final Residual ratio : 0.00490676 - Residual ratio : 0.000602399 - Slope : -0.271349 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.69029 - Final Residual ratio : 0.00552023 - Residual ratio : 0.000717818 - Slope : -0.256159 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.17641 - Final Residual ratio : 0.00644957 - Residual ratio : 0.000898718 - Slope : -0.24724 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 111 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 111 - - Mesh vertices: 108 - Mesh triangles: 111 - Mesh edges: 182 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1451 -matrix_partition : [5](0,44,88,132,178) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000431776 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.262160e+05 Mflops = 313.25 -Solve time = 0.00 -Solve flops = 1.366400e+04 Mflops = 469.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0617787; expected ratio = 0.0001obtained abs = 0.000852048; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.505157; expected ratio = 0.001obtained abs = 233.395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.229700e+05 Mflops = 315.27 -Solve time = 0.00 -Solve flops = 1.345600e+04 Mflops = 462.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0388235; expected ratio = 0.0001obtained abs = 0.00053119; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.266025; expected ratio = 0.001obtained abs = 123.826; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.219170e+05 Mflops = 311.80 -Solve time = 0.00 -Solve flops = 1.341000e+04 Mflops = 464.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00858784; expected ratio = 0.0001obtained abs = 0.000117355; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.550121; expected ratio = 0.001obtained abs = 265.798; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.227690e+05 Mflops = 311.51 -Solve time = 0.00 -Solve flops = 1.346200e+04 Mflops = 462.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00312928; expected ratio = 0.0001obtained abs = 4.27766e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.570871; expected ratio = 0.001obtained abs = 253.663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.219590e+05 Mflops = 311.15 -Solve time = 0.00 -Solve flops = 1.341400e+04 Mflops = 461.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00106761; expected ratio = 0.0001obtained abs = 1.45955e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.376157; expected ratio = 0.001obtained abs = 173.04; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.218090e+05 Mflops = 311.53 -Solve time = 0.00 -Solve flops = 1.340400e+04 Mflops = 460.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000407133; expected ratio = 0.0001obtained abs = 5.5657e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.344706; expected ratio = 0.001obtained abs = 153.146; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.225030e+05 Mflops = 314.07 -Solve time = 0.00 -Solve flops = 1.344600e+04 Mflops = 462.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00021968; expected ratio = 0.0001obtained abs = 3.00315e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.236249; expected ratio = 0.001obtained abs = 106.874; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.225030e+05 Mflops = 313.30 -Solve time = 0.00 -Solve flops = 1.344600e+04 Mflops = 466.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000163658; expected ratio = 0.0001obtained abs = 2.23729e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.223064; expected ratio = 0.001obtained abs = 99.1407; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.225030e+05 Mflops = 312.35 -Solve time = 0.00 -Solve flops = 1.344600e+04 Mflops = 466.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000113473; expected ratio = 0.0001obtained abs = 1.55126e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.19502; expected ratio = 0.001obtained abs = 88.7398; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.225030e+05 Mflops = 312.54 -Solve time = 0.00 -Solve flops = 1.344600e+04 Mflops = 462.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.85116e-05; expected ratio = 0.0001obtained abs = 1.34672e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.178561; expected ratio = 0.001obtained abs = 79.4304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.41765 - Final Residual ratio : 0.00590439 - Residual ratio : 0.000920025 - Slope : -0.320587 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.68188 - Final Residual ratio : 0.00474762 - Residual ratio : 0.000835573 - Slope : -0.195763 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.09751 - Final Residual ratio : 0.0046594 - Residual ratio : 0.000914054 - Slope : -0.181888 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.72619 - Final Residual ratio : 0.00358762 - Residual ratio : 0.000759094 - Slope : -0.168664 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.57106 - Final Residual ratio : 0.00418511 - Residual ratio : 0.000915566 - Slope : -0.152229 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.33756 - Final Residual ratio : 0.00391112 - Residual ratio : 0.000901688 - Slope : -0.144455 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.10564 - Final Residual ratio : 0.00339049 - Residual ratio : 0.000825814 - Slope : -0.136742 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.83701 - Final Residual ratio : 0.0037681 - Residual ratio : 0.00098204 - Slope : -0.132181 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5644 - Final Residual ratio : 0.00211157 - Residual ratio : 0.000592406 - Slope : -0.122837 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.41159 - Final Residual ratio : 0.00285683 - Residual ratio : 0.000837388 - Slope : -0.121741 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 111 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 111 - - Mesh vertices: 108 - Mesh triangles: 111 - Mesh edges: 182 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1551 -matrix_partition : [5](0,44,88,132,178) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.219590e+05 Mflops = 310.21 -Solve time = 0.00 -Solve flops = 1.341400e+04 Mflops = 446.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0614896; expected ratio = 0.0001obtained abs = 0.000831302; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.526848; expected ratio = 0.001obtained abs = 166.856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.263120e+05 Mflops = 323.83 -Solve time = 0.00 -Solve flops = 1.367000e+04 Mflops = 490.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0338043; expected ratio = 0.0001obtained abs = 0.000460488; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.145707; expected ratio = 0.001obtained abs = 45.6879; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.259080e+05 Mflops = 323.59 -Solve time = 0.00 -Solve flops = 1.364200e+04 Mflops = 472.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00300441; expected ratio = 0.0001obtained abs = 4.08988e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.109634; expected ratio = 0.001obtained abs = 35.4616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.259080e+05 Mflops = 324.58 -Solve time = 0.00 -Solve flops = 1.364200e+04 Mflops = 469.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00114873; expected ratio = 0.0001obtained abs = 1.56385e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.14199; expected ratio = 0.001obtained abs = 44.6014; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.266100e+05 Mflops = 324.80 -Solve time = 0.00 -Solve flops = 1.368400e+04 Mflops = 470.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00143266; expected ratio = 0.0001obtained abs = 1.95036e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.156151; expected ratio = 0.001obtained abs = 48.7711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.256680e+05 Mflops = 323.96 -Solve time = 0.00 -Solve flops = 1.362600e+04 Mflops = 468.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00165348; expected ratio = 0.0001obtained abs = 2.25097e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0937851; expected ratio = 0.001obtained abs = 29.8511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258180e+05 Mflops = 324.35 -Solve time = 0.00 -Solve flops = 1.363600e+04 Mflops = 468.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00143314; expected ratio = 0.0001obtained abs = 1.95099e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0739594; expected ratio = 0.001obtained abs = 23.1546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258180e+05 Mflops = 323.56 -Solve time = 0.00 -Solve flops = 1.363600e+04 Mflops = 468.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00142295; expected ratio = 0.0001obtained abs = 1.93712e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0689055; expected ratio = 0.001obtained abs = 21.4146; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258180e+05 Mflops = 324.35 -Solve time = 0.00 -Solve flops = 1.363600e+04 Mflops = 468.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000862357; expected ratio = 0.0001obtained abs = 1.17396e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0539157; expected ratio = 0.001obtained abs = 16.7334; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258180e+05 Mflops = 325.15 -Solve time = 0.00 -Solve flops = 1.363600e+04 Mflops = 468.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000647966; expected ratio = 0.0001obtained abs = 8.82101e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0468526; expected ratio = 0.001obtained abs = 14.5254; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258180e+05 Mflops = 323.56 -Solve time = 0.00 -Solve flops = 1.363600e+04 Mflops = 468.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000338709; expected ratio = 0.0001obtained abs = 4.61097e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0438193; expected ratio = 0.001obtained abs = 13.5817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258180e+05 Mflops = 323.36 -Solve time = 0.00 -Solve flops = 1.363600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000247432; expected ratio = 0.0001obtained abs = 3.36839e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0421582; expected ratio = 0.001obtained abs = 13.081; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258180e+05 Mflops = 324.15 -Solve time = 0.00 -Solve flops = 1.363600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000115197; expected ratio = 0.0001obtained abs = 1.56822e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0415567; expected ratio = 0.001obtained abs = 12.8619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.258180e+05 Mflops = 324.15 -Solve time = 0.00 -Solve flops = 1.363600e+04 Mflops = 468.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.78395e-05; expected ratio = 0.0001obtained abs = 1.33193e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0398281; expected ratio = 0.001obtained abs = 12.3584; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.6777 - Final Residual ratio : 0.0294809 - Residual ratio : 0.000902172 - Slope : -1.20919 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.0766 - Final Residual ratio : 0.0127163 - Residual ratio : 0.000843449 - Slope : -0.502128 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2347 - Final Residual ratio : 0.0145172 - Residual ratio : 0.000894207 - Slope : -0.540672 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.0716 - Final Residual ratio : 0.0151729 - Residual ratio : 0.000888781 - Slope : -0.609159 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 185.044 - Final Residual ratio : 0.150107 - Residual ratio : 0.000811197 - Slope : -9.2447 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 78.9787 - Final Residual ratio : 0.0754155 - Residual ratio : 0.000954885 - Slope : -2.81797 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.7331 - Final Residual ratio : 0.0678168 - Residual ratio : 0.000945405 - Slope : -2.75636 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.5224 - Final Residual ratio : 0.017894 - Residual ratio : 0.000794495 - Slope : -0.750151 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.0647 - Final Residual ratio : 0.016022 - Residual ratio : 0.000886921 - Slope : -0.601624 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.4691 - Final Residual ratio : 0.0139009 - Residual ratio : 0.000844059 - Slope : -0.548506 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 14 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 111 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 110 - - Mesh vertices: 108 - Mesh triangles: 110 - Mesh edges: 181 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1651 -matrix_partition : [5](0,44,88,132,178) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.256190e+05 Mflops = 327.26 -Solve time = 0.00 -Solve flops = 1.362800e+04 Mflops = 453.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0647235; expected ratio = 0.0001obtained abs = 0.000879213; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.250534; expected ratio = 0.001obtained abs = 97.0769; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.244750e+05 Mflops = 325.08 -Solve time = 0.00 -Solve flops = 1.355000e+04 Mflops = 465.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0108993; expected ratio = 0.0001obtained abs = 0.000148005; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.075794; expected ratio = 0.001obtained abs = 30.596; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.250150e+05 Mflops = 327.11 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 470.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00484729; expected ratio = 0.0001obtained abs = 6.58171e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0897894; expected ratio = 0.001obtained abs = 36.2527; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.250150e+05 Mflops = 317.40 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 452.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00160874; expected ratio = 0.0001obtained abs = 2.18419e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131917; expected ratio = 0.001obtained abs = 51.7654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.250150e+05 Mflops = 326.49 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 467.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000757602; expected ratio = 0.0001obtained abs = 1.02859e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0643592; expected ratio = 0.001obtained abs = 25.1555; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.250150e+05 Mflops = 327.31 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 452.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000399172; expected ratio = 0.0001obtained abs = 5.41946e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0424233; expected ratio = 0.001obtained abs = 16.5863; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.250150e+05 Mflops = 326.29 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 470.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000241167; expected ratio = 0.0001obtained abs = 3.27428e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0458086; expected ratio = 0.001obtained abs = 18.0537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.250150e+05 Mflops = 327.31 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 467.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000228274; expected ratio = 0.0001obtained abs = 3.09922e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0456123; expected ratio = 0.001obtained abs = 18.038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.250150e+05 Mflops = 327.31 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 452.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000181982; expected ratio = 0.0001obtained abs = 2.47072e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0383459; expected ratio = 0.001obtained abs = 14.919; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,110) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.250150e+05 Mflops = 325.48 -Solve time = 0.00 -Solve flops = 1.358600e+04 Mflops = 467.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.93506e-05; expected ratio = 0.0001obtained abs = 1.07732e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0347731; expected ratio = 0.001obtained abs = 13.496; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.0282 - Final Residual ratio : 0.013947 - Residual ratio : 0.000819053 - Slope : -0.5867 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.2486 - Final Residual ratio : 0.0197597 - Residual ratio : 0.000975859 - Slope : -0.652542 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.8569 - Final Residual ratio : 0.0173524 - Residual ratio : 0.000873875 - Slope : -0.763058 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.0897 - Final Residual ratio : 0.0126912 - Residual ratio : 0.000742622 - Slope : -0.569234 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1701 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.831 - Final Residual ratio : 0.010808 - Residual ratio : 0.00078143 - Slope : -0.445814 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.4057 - Final Residual ratio : 0.00759139 - Residual ratio : 0.000665581 - Slope : -0.379936 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1568 - Final Residual ratio : 0.00631177 - Residual ratio : 0.000621435 - Slope : -0.338349 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1731 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.61405 - Final Residual ratio : 0.00708124 - Residual ratio : 0.000736551 - Slope : -0.320232 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.12234 - Final Residual ratio : 0.00808043 - Residual ratio : 0.000885785 - Slope : -0.303809 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.38897 - Final Residual ratio : 0.00682052 - Residual ratio : 0.000813033 - Slope : -0.465675 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 110 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 110 - - Mesh vertices: 109 - Mesh triangles: 112 - Mesh edges: 184 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1751 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.568720e+05 Mflops = 338.11 -Solve time = 0.00 -Solve flops = 1.493600e+04 Mflops = 453.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0614007; expected ratio = 0.0001obtained abs = 0.000827276; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.172143; expected ratio = 0.001obtained abs = 58.3851; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574480e+05 Mflops = 342.17 -Solve time = 0.00 -Solve flops = 1.497000e+04 Mflops = 482.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0228227; expected ratio = 0.0001obtained abs = 0.000306528; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0726446; expected ratio = 0.001obtained abs = 24.9665; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574480e+05 Mflops = 335.05 -Solve time = 0.00 -Solve flops = 1.497000e+04 Mflops = 482.99 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00453601; expected ratio = 0.0001obtained abs = 6.08614e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0734108; expected ratio = 0.001obtained abs = 25.1596; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.572500e+05 Mflops = 341.92 -Solve time = 0.00 -Solve flops = 1.495200e+04 Mflops = 482.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0025772; expected ratio = 0.0001obtained abs = 3.45639e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0625191; expected ratio = 0.001obtained abs = 21.3294; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.572500e+05 Mflops = 341.03 -Solve time = 0.00 -Solve flops = 1.495200e+04 Mflops = 482.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00197184; expected ratio = 0.0001obtained abs = 2.64358e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0765309; expected ratio = 0.001obtained abs = 26.2593; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000398874 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.572500e+05 Mflops = 342.63 -Solve time = 0.00 -Solve flops = 1.495200e+04 Mflops = 482.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00160132; expected ratio = 0.0001obtained abs = 2.14625e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0760833; expected ratio = 0.001obtained abs = 26.4395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000399113 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.572500e+05 Mflops = 341.92 -Solve time = 0.00 -Solve flops = 1.495200e+04 Mflops = 482.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00131475; expected ratio = 0.0001obtained abs = 1.76176e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0468273; expected ratio = 0.001obtained abs = 16.0183; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000399113 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 342.38 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107996; expected ratio = 0.0001obtained abs = 1.44687e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170776; expected ratio = 0.001obtained abs = 5.85531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000400066 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 342.21 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000905754; expected ratio = 0.0001obtained abs = 1.21329e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.016479; expected ratio = 0.001obtained abs = 5.67194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000404835 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.578300e+05 Mflops = 342.47 -Solve time = 0.00 -Solve flops = 1.499000e+04 Mflops = 483.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000778754; expected ratio = 0.0001obtained abs = 1.04303e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00989449; expected ratio = 0.001obtained abs = 3.40254; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 332.89 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000663205; expected ratio = 0.0001obtained abs = 8.88167e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00675422; expected ratio = 0.001obtained abs = 2.32092; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000401974 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 341.68 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000568147; expected ratio = 0.0001obtained abs = 7.60792e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00327362; expected ratio = 0.001obtained abs = 1.12586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000399828 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 342.38 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000492402; expected ratio = 0.0001obtained abs = 6.59308e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00312202; expected ratio = 0.001obtained abs = 1.07455; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000400066 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 342.21 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000428895; expected ratio = 0.0001obtained abs = 5.74233e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00144613; expected ratio = 0.001obtained abs = 0.497684; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000401974 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 342.38 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000373232; expected ratio = 0.0001obtained abs = 4.99676e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00130749; expected ratio = 0.001obtained abs = 0.450066; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 342.38 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000326524; expected ratio = 0.0001obtained abs = 4.37121e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000963836; expected ratio = 0.001obtained abs = 0.331876; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 342.21 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000286586; expected ratio = 0.0001obtained abs = 3.83637e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00074588; expected ratio = 0.001obtained abs = 0.25687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 341.50 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000252138; expected ratio = 0.0001obtained abs = 3.37509e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000587245; expected ratio = 0.001obtained abs = 0.202266; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 332.89 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 468.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000222095; expected ratio = 0.0001obtained abs = 2.97283e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000553067; expected ratio = 0.001obtained abs = 0.190521; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000403166 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.574660e+05 Mflops = 342.38 -Solve time = 0.00 -Solve flops = 1.496400e+04 Mflops = 482.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000196175; expected ratio = 0.0001obtained abs = 2.62579e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000496847; expected ratio = 0.001obtained abs = 0.171178; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.55538 - Final Residual ratio : 0.00518069 - Residual ratio : 0.000685696 - Slope : -0.243555 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.71625 - Final Residual ratio : 0.00648874 - Residual ratio : 0.000966125 - Slope : -0.223659 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.0073 - Final Residual ratio : 0.00540375 - Residual ratio : 0.00089953 - Slope : -0.200063 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.45622 - Final Residual ratio : 0.00474581 - Residual ratio : 0.000869797 - Slope : -0.194696 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.04693 - Final Residual ratio : 0.00458814 - Residual ratio : 0.000909095 - Slope : -0.180084 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.71084 - Final Residual ratio : 0.00358117 - Residual ratio : 0.000760199 - Slope : -0.162319 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.44845 - Final Residual ratio : 0.00260329 - Residual ratio : 0.000585213 - Slope : -0.148195 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.24386 - Final Residual ratio : 0.00379886 - Residual ratio : 0.000895143 - Slope : -0.146209 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.08708 - Final Residual ratio : 0.00271222 - Residual ratio : 0.000663607 - Slope : -0.14084 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.00086 - Final Residual ratio : 0.00367334 - Residual ratio : 0.000918137 - Slope : -0.166549 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 112 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 112 - - Mesh vertices: 109 - Mesh triangles: 112 - Mesh edges: 184 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1851 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.583330e+05 Mflops = 339.87 -Solve time = 0.00 -Solve flops = 1.500000e+04 Mflops = 483.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0543513; expected ratio = 0.0001obtained abs = 0.000717204; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0889183; expected ratio = 0.001obtained abs = 32.8779; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000403166 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.581170e+05 Mflops = 341.50 -Solve time = 0.00 -Solve flops = 1.498800e+04 Mflops = 469.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0122876; expected ratio = 0.0001obtained abs = 0.00016269; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0339053; expected ratio = 0.001obtained abs = 12.6025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.581170e+05 Mflops = 340.10 -Solve time = 0.00 -Solve flops = 1.498800e+04 Mflops = 483.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00183823; expected ratio = 0.0001obtained abs = 2.43347e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0169945; expected ratio = 0.001obtained abs = 6.33407; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000401974 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.585190e+05 Mflops = 340.96 -Solve time = 0.00 -Solve flops = 1.501800e+04 Mflops = 484.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000992246; expected ratio = 0.0001obtained abs = 1.31375e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0123642; expected ratio = 0.001obtained abs = 4.61543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.585190e+05 Mflops = 340.96 -Solve time = 0.00 -Solve flops = 1.501800e+04 Mflops = 484.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000363394; expected ratio = 0.0001obtained abs = 4.81146e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162927; expected ratio = 0.001obtained abs = 6.09519; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.585190e+05 Mflops = 341.66 -Solve time = 0.00 -Solve flops = 1.501800e+04 Mflops = 484.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000251909; expected ratio = 0.0001obtained abs = 3.33543e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106429; expected ratio = 0.001obtained abs = 3.97473; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.00040102 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.585190e+05 Mflops = 340.96 -Solve time = 0.00 -Solve flops = 1.501800e+04 Mflops = 484.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000177198; expected ratio = 0.0001obtained abs = 2.34624e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0124774; expected ratio = 0.001obtained abs = 4.65258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.585190e+05 Mflops = 341.66 -Solve time = 0.00 -Solve flops = 1.501800e+04 Mflops = 470.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000138476; expected ratio = 0.0001obtained abs = 1.83356e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0228292; expected ratio = 0.001obtained abs = 8.55047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000403166 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.585190e+05 Mflops = 340.96 -Solve time = 0.00 -Solve flops = 1.501800e+04 Mflops = 484.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000137491; expected ratio = 0.0001obtained abs = 1.82053e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0328597; expected ratio = 0.001obtained abs = 12.3286; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.585190e+05 Mflops = 341.66 -Solve time = 0.00 -Solve flops = 1.501800e+04 Mflops = 484.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.68265e-05; expected ratio = 0.0001obtained abs = 1.2821e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234805; expected ratio = 0.001obtained abs = 8.74589; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.88039 - Final Residual ratio : 0.0030151 - Residual ratio : 0.00077701 - Slope : -0.138478 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1871 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.76781 - Final Residual ratio : 0.00330992 - Residual ratio : 0.000878474 - Slope : -0.12981 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.62582 - Final Residual ratio : 0.0027735 - Residual ratio : 0.000764931 - Slope : -0.120768 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.45738 - Final Residual ratio : 0.00259294 - Residual ratio : 0.000749973 - Slope : -0.115159 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.31725 - Final Residual ratio : 0.00292926 - Residual ratio : 0.000883038 - Slope : -0.122753 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.15572 - Final Residual ratio : 0.00287412 - Residual ratio : 0.000910765 - Slope : -0.121263 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.05147 - Final Residual ratio : 0.00293159 - Residual ratio : 0.000960717 - Slope : -0.108876 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.97148 - Final Residual ratio : 0.00280923 - Residual ratio : 0.000945398 - Slope : -0.102368 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.89791 - Final Residual ratio : 0.00205133 - Residual ratio : 0.000707867 - Slope : -0.0965286 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1951 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.89885 - Final Residual ratio : 0.00205138 - Residual ratio : 0.000707651 - Slope : -0.0965601 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.1951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 112 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 111 - - Mesh vertices: 108 - Mesh triangles: 111 - Mesh edges: 182 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.1951 -matrix_partition : [5](0,44,88,132,178) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.287640e+05 Mflops = 320.33 -Solve time = 0.00 -Solve flops = 1.383800e+04 Mflops = 443.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0584051; expected ratio = 0.0001obtained abs = 0.000758095; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0597155; expected ratio = 0.001obtained abs = 22.3535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.287640e+05 Mflops = 322.63 -Solve time = 0.00 -Solve flops = 1.383800e+04 Mflops = 446.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00466417; expected ratio = 0.0001obtained abs = 6.05858e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0485642; expected ratio = 0.001obtained abs = 18.2576; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.290340e+05 Mflops = 321.76 -Solve time = 0.00 -Solve flops = 1.385800e+04 Mflops = 461.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00264675; expected ratio = 0.0001obtained abs = 3.43725e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.098874; expected ratio = 0.001obtained abs = 37.6985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.284460e+05 Mflops = 321.83 -Solve time = 0.00 -Solve flops = 1.381400e+04 Mflops = 459.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00290719; expected ratio = 0.0001obtained abs = 3.77611e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.115356; expected ratio = 0.001obtained abs = 43.9013; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.287640e+05 Mflops = 321.86 -Solve time = 0.00 -Solve flops = 1.383800e+04 Mflops = 446.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00178876; expected ratio = 0.0001obtained abs = 2.32321e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0814394; expected ratio = 0.001obtained abs = 30.5856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.287640e+05 Mflops = 321.86 -Solve time = 0.00 -Solve flops = 1.383800e+04 Mflops = 446.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000220725; expected ratio = 0.0001obtained abs = 2.86674e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0520681; expected ratio = 0.001obtained abs = 19.6564; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.287640e+05 Mflops = 321.86 -Solve time = 0.00 -Solve flops = 1.383800e+04 Mflops = 446.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000142374; expected ratio = 0.0001obtained abs = 1.84917e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0498199; expected ratio = 0.001obtained abs = 18.9826; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,27,54,81,111) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 178 -RHS size in solver: 178 -Factor time = 0.00 -Factor flops = 1.287640e+05 Mflops = 322.82 -Solve time = 0.00 -Solve flops = 1.383800e+04 Mflops = 446.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.23503e-05; expected ratio = 0.0001obtained abs = 1.06958e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0338363; expected ratio = 0.001obtained abs = 12.7359; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.1961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.7497 - Final Residual ratio : 0.010699 - Residual ratio : 0.000725371 - Slope : -0.491301 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.505 - Final Residual ratio : 0.0263543 - Residual ratio : 0.000810777 - Slope : -1.08262 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.5602 - Final Residual ratio : 0.0222562 - Residual ratio : 0.000643984 - Slope : -1.15126 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.1991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 51.3451 - Final Residual ratio : 0.0460066 - Residual ratio : 0.000896027 - Slope : -1.70997 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.1991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.541 - Final Residual ratio : 0.0369542 - Residual ratio : 0.000984367 - Slope : -1.63061 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.9728 - Final Residual ratio : 0.0164435 - Residual ratio : 0.000609632 - Slope : -0.898545 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.6161 - Final Residual ratio : 0.0113904 - Residual ratio : 0.000729405 - Slope : -0.503377 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.5212 - Final Residual ratio : 0.013692 - Residual ratio : 0.00088215 - Slope : -0.534743 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.7741 - Final Residual ratio : 0.00881447 - Residual ratio : 0.000558792 - Slope : -0.525511 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.9576 - Final Residual ratio : 0.0129883 - Residual ratio : 0.000868344 - Slope : -0.467018 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 108 - Number of Properties : 2 - Number of Elements : 111 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 111 - - Mesh vertices: 109 - Mesh triangles: 113 - Mesh edges: 185 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2051 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000418186 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.454540e+05 Mflops = 326.07 -Solve time = 0.00 -Solve flops = 1.473600e+04 Mflops = 447.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0603304; expected ratio = 0.0001obtained abs = 0.000800629; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.113807; expected ratio = 0.001obtained abs = 39.3207; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.450640e+05 Mflops = 321.59 -Solve time = 0.00 -Solve flops = 1.471200e+04 Mflops = 460.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00638788; expected ratio = 0.0001obtained abs = 8.48783e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0497744; expected ratio = 0.001obtained abs = 17.4631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00133688; expected ratio = 0.0001obtained abs = 1.7762e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0524235; expected ratio = 0.001obtained abs = 18.3768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.73 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000552275; expected ratio = 0.0001obtained abs = 7.33803e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0398178; expected ratio = 0.001obtained abs = 13.9019; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.73 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000299674; expected ratio = 0.0001obtained abs = 3.98164e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0480924; expected ratio = 0.001obtained abs = 16.7442; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000128296; expected ratio = 0.0001obtained abs = 1.70464e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0505318; expected ratio = 0.001obtained abs = 17.7031; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000418186 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 317.79 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 456.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000750265; expected ratio = 0.0001obtained abs = 9.96824e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0216738; expected ratio = 0.001obtained abs = 7.56102; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000408888 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000834951; expected ratio = 0.0001obtained abs = 1.10937e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0169092; expected ratio = 0.001obtained abs = 5.89617; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000408173 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.73 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000327901; expected ratio = 0.0001obtained abs = 4.35677e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0213394; expected ratio = 0.001obtained abs = 7.45196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 323.37 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000182264; expected ratio = 0.0001obtained abs = 2.42168e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0218372; expected ratio = 0.001obtained abs = 7.62494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 443.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000767595; expected ratio = 0.0001obtained abs = 1.01985e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0215711; expected ratio = 0.001obtained abs = 7.51865; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 474.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000843941; expected ratio = 0.0001obtained abs = 1.12131e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0205997; expected ratio = 0.001obtained abs = 7.19328; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.73 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000329122; expected ratio = 0.0001obtained abs = 4.37301e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0180423; expected ratio = 0.001obtained abs = 6.29934; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000175089; expected ratio = 0.0001obtained abs = 2.32635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162563; expected ratio = 0.001obtained abs = 5.67508; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000418186 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 318.45 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 474.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000764513; expected ratio = 0.0001obtained abs = 1.01576e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0177452; expected ratio = 0.001obtained abs = 6.18586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000409842 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000842812; expected ratio = 0.0001obtained abs = 1.11981e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0188887; expected ratio = 0.001obtained abs = 6.59553; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000327268; expected ratio = 0.0001obtained abs = 4.34837e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0174815; expected ratio = 0.001obtained abs = 6.10333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 456.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000174091; expected ratio = 0.0001obtained abs = 2.31309e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162236; expected ratio = 0.001obtained abs = 5.66385; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000408173 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.02 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 474.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000764379; expected ratio = 0.0001obtained abs = 1.01558e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0177016; expected ratio = 0.001obtained abs = 6.17046; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.448660e+05 Mflops = 327.73 -Solve time = 0.00 -Solve flops = 1.469400e+04 Mflops = 456.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000842742; expected ratio = 0.0001obtained abs = 1.11972e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187082; expected ratio = 0.001obtained abs = 6.53269; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.3407 - Final Residual ratio : 0.00615026 - Residual ratio : 0.000461016 - Slope : -0.416704 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.6278 - Final Residual ratio : 0.0070234 - Residual ratio : 0.000604015 - Slope : -0.387361 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.93558 - Final Residual ratio : 0.00647962 - Residual ratio : 0.000652163 - Slope : -0.320294 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.18308 - Final Residual ratio : 0.00654068 - Residual ratio : 0.000799293 - Slope : -0.255517 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.60664 - Final Residual ratio : 0.00608041 - Residual ratio : 0.000920348 - Slope : -0.212921 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.26839 - Final Residual ratio : 0.00420796 - Residual ratio : 0.000671299 - Slope : -0.20207 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.3756 - Final Residual ratio : 0.0170665 - Residual ratio : 0.000700146 - Slope : -0.811951 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.4218 - Final Residual ratio : 0.0261584 - Residual ratio : 0.000889081 - Slope : -1.04984 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.35646 - Final Residual ratio : 0.00710138 - Residual ratio : 0.000965325 - Slope : -0.244979 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.75495 - Final Residual ratio : 0.00419656 - Residual ratio : 0.000541146 - Slope : -0.258358 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 113 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 110 - - Mesh vertices: 109 - Mesh triangles: 112 - Mesh edges: 184 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2151 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.588860e+05 Mflops = 344.05 -Solve time = 0.00 -Solve flops = 1.506800e+04 Mflops = 468.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0644179; expected ratio = 0.0001obtained abs = 0.000833347; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0630558; expected ratio = 0.001obtained abs = 22.0099; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.588860e+05 Mflops = 347.63 -Solve time = 0.00 -Solve flops = 1.506800e+04 Mflops = 471.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00538496; expected ratio = 0.0001obtained abs = 6.9733e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0154756; expected ratio = 0.001obtained abs = 5.42807; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.588860e+05 Mflops = 337.94 -Solve time = 0.00 -Solve flops = 1.506800e+04 Mflops = 486.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000683029; expected ratio = 0.0001obtained abs = 8.84449e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0274825; expected ratio = 0.001obtained abs = 9.61562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.588860e+05 Mflops = 346.19 -Solve time = 0.00 -Solve flops = 1.506800e+04 Mflops = 486.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000162949; expected ratio = 0.0001obtained abs = 2.11007e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0347793; expected ratio = 0.001obtained abs = 12.1867; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.588860e+05 Mflops = 347.63 -Solve time = 0.00 -Solve flops = 1.506800e+04 Mflops = 471.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000103764; expected ratio = 0.0001obtained abs = 1.34368e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.037377; expected ratio = 0.001obtained abs = 13.0733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.588860e+05 Mflops = 346.19 -Solve time = 0.00 -Solve flops = 1.506800e+04 Mflops = 486.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00093939; expected ratio = 0.0001obtained abs = 1.21644e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0367472; expected ratio = 0.001obtained abs = 12.8531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000401974 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.588860e+05 Mflops = 341.05 -Solve time = 0.00 -Solve flops = 1.506800e+04 Mflops = 486.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000979363; expected ratio = 0.0001obtained abs = 1.26823e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0335707; expected ratio = 0.001obtained abs = 11.7489; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.588860e+05 Mflops = 346.91 -Solve time = 0.00 -Solve flops = 1.506800e+04 Mflops = 471.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.4743e-05; expected ratio = 0.0001obtained abs = 1.22688e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0284481; expected ratio = 0.001obtained abs = 9.96244; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.74997 - Final Residual ratio : 0.00487973 - Residual ratio : 0.000557685 - Slope : -0.265003 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2171 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 45.3371 - Final Residual ratio : 0.0305777 - Residual ratio : 0.000674451 - Slope : -1.67802 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3495 - Final Residual ratio : 0.0115381 - Residual ratio : 0.000705717 - Slope : -0.5446 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.01936 - Final Residual ratio : 0.00655809 - Residual ratio : 0.000934286 - Slope : -0.241821 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.24401 - Final Residual ratio : 0.00469964 - Residual ratio : 0.000896193 - Slope : -0.180666 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.28114 - Final Residual ratio : 0.00462936 - Residual ratio : 0.000737026 - Slope : -0.224161 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.67501 - Final Residual ratio : 0.00654444 - Residual ratio : 0.000980439 - Slope : -0.24698 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.15913 - Final Residual ratio : 0.00522669 - Residual ratio : 0.000848608 - Slope : -0.20513 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2241 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.19777 - Final Residual ratio : 0.00359492 - Residual ratio : 0.000691626 - Slope : -0.17911 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.46659 - Final Residual ratio : 0.00340985 - Residual ratio : 0.000763413 - Slope : -0.148773 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 112 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 110 - - Mesh vertices: 109 - Mesh triangles: 112 - Mesh edges: 184 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2251 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 344.89 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 468.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0625187; expected ratio = 0.0001obtained abs = 0.000804769; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0565535; expected ratio = 0.001obtained abs = 19.8709; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000399113 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 346.52 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 465.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00634808; expected ratio = 0.0001obtained abs = 8.17613e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0299403; expected ratio = 0.001obtained abs = 10.537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000400066 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 346.52 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 483.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00105808; expected ratio = 0.0001obtained abs = 1.36276e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0268419; expected ratio = 0.001obtained abs = 9.44582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000400782 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 347.25 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 468.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00025236; expected ratio = 0.0001obtained abs = 3.25038e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01746; expected ratio = 0.001obtained abs = 6.14274; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000397921 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 345.79 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 483.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000212398; expected ratio = 0.0001obtained abs = 2.73572e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0106325; expected ratio = 0.001obtained abs = 3.73873; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000398874 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 347.25 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 483.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00016913; expected ratio = 0.0001obtained abs = 2.17846e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00667983; expected ratio = 0.001obtained abs = 2.35088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000396967 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 348.17 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 465.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000144965; expected ratio = 0.0001obtained abs = 1.86722e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00421275; expected ratio = 0.001obtained abs = 1.48141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000399113 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 347.25 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 468.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000124279; expected ratio = 0.0001obtained abs = 1.6008e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00266968; expected ratio = 0.001obtained abs = 0.938924; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000398874 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 346.52 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 483.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000102566; expected ratio = 0.0001obtained abs = 1.32113e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00175198; expected ratio = 0.001obtained abs = 0.616226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000397921 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.569720e+05 Mflops = 347.25 -Solve time = 0.00 -Solve flops = 1.497200e+04 Mflops = 468.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.72049e-05; expected ratio = 0.0001obtained abs = 1.12328e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00121906; expected ratio = 0.001obtained abs = 0.428667; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.20989 - Final Residual ratio : 0.00366037 - Residual ratio : 0.000869469 - Slope : -0.145042 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.27511 - Final Residual ratio : 0.00359044 - Residual ratio : 0.000839848 - Slope : -0.137791 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.15796 - Final Residual ratio : 0.00322868 - Residual ratio : 0.000776506 - Slope : -0.148383 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2291 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.70984 - Final Residual ratio : 0.00308338 - Residual ratio : 0.000831137 - Slope : -0.127819 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 4.2301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.126 - Final Residual ratio : 0.00238704 - Residual ratio : 0.00076361 - Slope : -0.107711 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.8222 - Final Residual ratio : 0.00253391 - Residual ratio : 0.000897848 - Slope : -0.0909569 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.93152 - Final Residual ratio : 0.00254838 - Residual ratio : 0.000869305 - Slope : -0.0976322 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2331 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.15549 - Final Residual ratio : 0.00281931 - Residual ratio : 0.000893461 - Slope : -0.101699 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.16766 - Final Residual ratio : 0.00243014 - Residual ratio : 0.00076717 - Slope : -0.0989135 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.96538 - Final Residual ratio : 0.00238695 - Residual ratio : 0.000804937 - Slope : -0.109741 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 112 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 112 - - Mesh vertices: 109 - Mesh triangles: 112 - Mesh edges: 184 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2351 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.567920e+05 Mflops = 349.25 -Solve time = 0.00 -Solve flops = 1.494800e+04 Mflops = 451.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0605714; expected ratio = 0.0001obtained abs = 0.000776815; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0299863; expected ratio = 0.001obtained abs = 10.547; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.567920e+05 Mflops = 351.49 -Solve time = 0.00 -Solve flops = 1.494800e+04 Mflops = 467.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00584851; expected ratio = 0.0001obtained abs = 7.50341e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00640326; expected ratio = 0.001obtained abs = 2.26344; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.567920e+05 Mflops = 350.74 -Solve time = 0.00 -Solve flops = 1.494800e+04 Mflops = 467.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000693726; expected ratio = 0.0001obtained abs = 8.90031e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00518131; expected ratio = 0.001obtained abs = 1.82887; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.567920e+05 Mflops = 351.49 -Solve time = 0.00 -Solve flops = 1.494800e+04 Mflops = 467.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000205786; expected ratio = 0.0001obtained abs = 2.64024e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00563325; expected ratio = 0.001obtained abs = 1.99047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.567920e+05 Mflops = 340.21 -Solve time = 0.00 -Solve flops = 1.494800e+04 Mflops = 464.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000161722; expected ratio = 0.0001obtained abs = 2.07492e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00580337; expected ratio = 0.001obtained abs = 2.04897; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.567920e+05 Mflops = 350.74 -Solve time = 0.00 -Solve flops = 1.494800e+04 Mflops = 467.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000136833; expected ratio = 0.0001obtained abs = 1.75563e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00444529; expected ratio = 0.001obtained abs = 1.56982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.567920e+05 Mflops = 350.74 -Solve time = 0.00 -Solve flops = 1.494800e+04 Mflops = 467.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000111321; expected ratio = 0.0001obtained abs = 1.4283e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00320544; expected ratio = 0.001obtained abs = 1.13176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.567920e+05 Mflops = 351.49 -Solve time = 0.00 -Solve flops = 1.494800e+04 Mflops = 467.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.33897e-05; expected ratio = 0.0001obtained abs = 1.19825e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00176494; expected ratio = 0.001obtained abs = 0.623145; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.57625 - Final Residual ratio : 0.001921 - Residual ratio : 0.000745657 - Slope : -0.0830429 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.442 - Final Residual ratio : 0.00189985 - Residual ratio : 0.000777989 - Slope : -0.0739423 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2381 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.54352 - Final Residual ratio : 0.00230731 - Residual ratio : 0.000907131 - Slope : -0.087628 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.64236 - Final Residual ratio : 0.0024154 - Residual ratio : 0.000914109 - Slope : -0.0824981 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.54958 - Final Residual ratio : 0.00224626 - Residual ratio : 0.000881033 - Slope : -0.0821719 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.24292 - Final Residual ratio : 0.00147434 - Residual ratio : 0.000657333 - Slope : -0.0747148 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.93752 - Final Residual ratio : 0.00183435 - Residual ratio : 0.000946752 - Slope : -0.0667478 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.86529 - Final Residual ratio : 0.000949075 - Residual ratio : 0.000508809 - Slope : -0.06014 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2441 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98658 - Final Residual ratio : 0.00148497 - Residual ratio : 0.000747498 - Slope : -0.0661699 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.8594 - Final Residual ratio : 0.00947545 - Residual ratio : 0.000961058 - Slope : -0.351783 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 112 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 112 - - Mesh vertices: 109 - Mesh triangles: 112 - Mesh edges: 184 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2451 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 357.94 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 472.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0611918; expected ratio = 0.0001obtained abs = 0.000781116; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.032218; expected ratio = 0.001obtained abs = 11.2381; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 359.65 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.006864; expected ratio = 0.0001obtained abs = 8.77265e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.012772; expected ratio = 0.001obtained abs = 4.46229; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.621670e+05 Mflops = 360.45 -Solve time = 0.00 -Solve flops = 1.511000e+04 Mflops = 487.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00235147; expected ratio = 0.0001obtained abs = 3.00619e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00808447; expected ratio = 0.001obtained abs = 2.82359; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 359.45 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00137544; expected ratio = 0.0001obtained abs = 1.75865e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00618234; expected ratio = 0.001obtained abs = 2.15805; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000414848 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 359.45 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00110829; expected ratio = 0.0001obtained abs = 1.41722e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00343068; expected ratio = 0.001obtained abs = 1.19606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 359.45 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000883085; expected ratio = 0.0001obtained abs = 1.12933e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00245064; expected ratio = 0.001obtained abs = 0.854225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 359.45 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000690731; expected ratio = 0.0001obtained abs = 8.83395e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0026007; expected ratio = 0.001obtained abs = 0.906178; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 359.45 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000535442; expected ratio = 0.0001obtained abs = 6.84828e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00152313; expected ratio = 0.001obtained abs = 0.530507; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000401974 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 358.70 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00041043; expected ratio = 0.0001obtained abs = 5.24958e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00127501; expected ratio = 0.001obtained abs = 0.444009; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000401974 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.621230e+05 Mflops = 357.89 -Solve time = 0.00 -Solve flops = 1.510400e+04 Mflops = 487.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000311996; expected ratio = 0.0001obtained abs = 3.99069e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000801389; expected ratio = 0.001obtained abs = 0.27901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.624470e+05 Mflops = 357.85 -Solve time = 0.00 -Solve flops = 1.512200e+04 Mflops = 487.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000224146; expected ratio = 0.0001obtained abs = 2.86709e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000531355; expected ratio = 0.001obtained abs = 0.18498; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.624470e+05 Mflops = 358.61 -Solve time = 0.00 -Solve flops = 1.512200e+04 Mflops = 487.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000139216; expected ratio = 0.0001obtained abs = 1.78077e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000581777; expected ratio = 0.001obtained abs = 0.202511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000404835 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.624470e+05 Mflops = 357.67 -Solve time = 0.00 -Solve flops = 1.512200e+04 Mflops = 487.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.73809e-05; expected ratio = 0.0001obtained abs = 9.89819e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000267497; expected ratio = 0.001obtained abs = 0.0931072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.5731 - Final Residual ratio : 0.0443977 - Residual ratio : 0.000844495 - Slope : -2.02034 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.3502 - Final Residual ratio : 0.0450891 - Residual ratio : 0.000913655 - Slope : -1.70018 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.4635 - Final Residual ratio : 0.0300791 - Residual ratio : 0.000692054 - Slope : -1.67052 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.2891 - Final Residual ratio : 0.0235245 - Residual ratio : 0.000776667 - Slope : -1.26106 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.0011 - Final Residual ratio : 0.0159742 - Residual ratio : 0.000726064 - Slope : -0.732837 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2511 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.3037 - Final Residual ratio : 0.0506637 - Residual ratio : 0.000968646 - Slope : -2.00973 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 57.7155 - Final Residual ratio : 0.0495824 - Residual ratio : 0.000859083 - Slope : -2.62118 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.119 - Final Residual ratio : 0.0118117 - Residual ratio : 0.000836587 - Slope : -0.470238 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.2338 - Final Residual ratio : 0.0141081 - Residual ratio : 0.000818625 - Slope : -0.573991 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2551 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.288 - Final Residual ratio : 0.00850758 - Residual ratio : 0.000492109 - Slope : -0.719979 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 13 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 112 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 112 - - Mesh vertices: 109 - Mesh triangles: 112 - Mesh edges: 184 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2551 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 354.94 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 468.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0663784; expected ratio = 0.0001obtained abs = 0.000845405; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0316785; expected ratio = 0.001obtained abs = 11.059; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 357.18 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00859144; expected ratio = 0.0001obtained abs = 0.000109364; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0223042; expected ratio = 0.001obtained abs = 7.8081; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 357.18 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000653874; expected ratio = 0.0001obtained abs = 8.3224e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211666; expected ratio = 0.001obtained abs = 7.40524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 356.43 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000235983; expected ratio = 0.0001obtained abs = 3.00349e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0187222; expected ratio = 0.001obtained abs = 6.5588; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000403166 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 357.94 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000168403; expected ratio = 0.0001obtained abs = 2.14331e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.013825; expected ratio = 0.001obtained abs = 4.83848; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 357.18 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00012293; expected ratio = 0.0001obtained abs = 1.56455e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00975922; expected ratio = 0.001obtained abs = 3.41766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000402927 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.618030e+05 Mflops = 357.94 -Solve time = 0.00 -Solve flops = 1.508400e+04 Mflops = 486.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.38451e-05; expected ratio = 0.0001obtained abs = 1.19437e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0066329; expected ratio = 0.001obtained abs = 2.32207; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.5705 - Final Residual ratio : 0.0109513 - Residual ratio : 0.000703333 - Slope : -0.536538 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4815 - Final Residual ratio : 0.0110398 - Residual ratio : 0.000818885 - Slope : -0.481088 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5859 - Final Residual ratio : 0.0107397 - Residual ratio : 0.000926964 - Slope : -0.463007 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0512 - Final Residual ratio : 0.00858569 - Residual ratio : 0.000854198 - Slope : -0.346296 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2601 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.86105 - Final Residual ratio : 0.00438378 - Residual ratio : 0.000494725 - Slope : -0.354267 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.3561 - Final Residual ratio : 0.00963519 - Residual ratio : 0.000779789 - Slope : -0.457278 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 122.888 - Final Residual ratio : 0.105403 - Residual ratio : 0.000857718 - Slope : -4.23388 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 79.2918 - Final Residual ratio : 0.0777594 - Residual ratio : 0.000980674 - Slope : -2.82907 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.5446 - Final Residual ratio : 0.0215676 - Residual ratio : 0.0005454 - Slope : -1.46381 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2651 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8541 - Final Residual ratio : 0.0116557 - Residual ratio : 0.000906768 - Slope : -0.642121 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 112 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 112 - - Mesh vertices: 109 - Mesh triangles: 112 - Mesh edges: 184 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2651 -matrix_partition : [5](0,45,90,135,181) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.474350e+05 Mflops = 326.15 -Solve time = 0.00 -Solve flops = 1.462800e+04 Mflops = 471.96 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0646188; expected ratio = 0.0001obtained abs = 0.000817961; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0515529; expected ratio = 0.001obtained abs = 18.5212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.472370e+05 Mflops = 327.79 -Solve time = 0.00 -Solve flops = 1.461000e+04 Mflops = 471.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00713064; expected ratio = 0.0001obtained abs = 9.03857e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0378134; expected ratio = 0.001obtained abs = 13.6654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.472370e+05 Mflops = 323.67 -Solve time = 0.00 -Solve flops = 1.461000e+04 Mflops = 471.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00230319; expected ratio = 0.0001obtained abs = 2.92042e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0285315; expected ratio = 0.001obtained abs = 10.2344; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.472370e+05 Mflops = 327.10 -Solve time = 0.00 -Solve flops = 1.461000e+04 Mflops = 490.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000965565; expected ratio = 0.0001obtained abs = 1.22454e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0186802; expected ratio = 0.001obtained abs = 6.69844; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000403881 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.472370e+05 Mflops = 327.10 -Solve time = 0.00 -Solve flops = 1.461000e+04 Mflops = 471.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000468994; expected ratio = 0.0001obtained abs = 5.94831e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0150447; expected ratio = 0.001obtained abs = 5.40586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.472370e+05 Mflops = 328.66 -Solve time = 0.00 -Solve flops = 1.461000e+04 Mflops = 471.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000218381; expected ratio = 0.0001obtained abs = 2.76986e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00932419; expected ratio = 0.001obtained abs = 3.34762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000404119 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.472370e+05 Mflops = 328.66 -Solve time = 0.00 -Solve flops = 1.461000e+04 Mflops = 471.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000104207; expected ratio = 0.0001obtained abs = 1.32175e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0053677; expected ratio = 0.001obtained abs = 1.92635; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,112) -time: 0.000405073 -"finished parallel building" : finished parallel building -matrix size in solver: 181 -RHS size in solver: 181 -Factor time = 0.00 -Factor flops = 1.472370e+05 Mflops = 328.66 -Solve time = 0.00 -Solve flops = 1.461000e+04 Mflops = 486.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.97727e-05; expected ratio = 0.0001obtained abs = 6.31314e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00388353; expected ratio = 0.001obtained abs = 1.39355; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.9118 - Final Residual ratio : 0.00740954 - Residual ratio : 0.000465662 - Slope : -0.44179 - Tolerance : 0.001 - Number of iterations : 36 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 121.163 - Final Residual ratio : 0.118242 - Residual ratio : 0.000975894 - Slope : -5.76404 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.9679 - Final Residual ratio : 0.0218353 - Residual ratio : 0.000683036 - Slope : -1.18319 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2691 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 190.81 - Final Residual ratio : 0.165182 - Residual ratio : 0.00086569 - Slope : -11.2144 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 76.3874 - Final Residual ratio : 0.0624678 - Residual ratio : 0.000817776 - Slope : -3.81625 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.8984 - Final Residual ratio : 0.0638278 - Residual ratio : 0.000940048 - Slope : -3.76859 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.9211 - Final Residual ratio : 0.0154964 - Residual ratio : 0.000676076 - Slope : -0.763522 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.2501 - Final Residual ratio : 0.00925659 - Residual ratio : 0.000649582 - Slope : -0.491062 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.7738 - Final Residual ratio : 0.0134551 - Residual ratio : 0.000716699 - Slope : -0.625344 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.2888 - Final Residual ratio : 0.0168831 - Residual ratio : 0.000793049 - Slope : -0.733516 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 109 - Number of Properties : 2 - Number of Elements : 112 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 108 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - - Mesh vertices: 108 - Mesh triangles: 159 - Mesh edges: 266 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 159 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 108 - Input triangles: 110 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 2 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2751 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.743890e+05 Mflops = 352.33 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 460.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0764164; expected ratio = 0.0001obtained abs = 0.000958893; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110985; expected ratio = 0.001obtained abs = 39.2087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.743890e+05 Mflops = 353.69 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 490.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00784053; expected ratio = 0.0001obtained abs = 9.83452e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0864333; expected ratio = 0.001obtained abs = 30.8434; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.743890e+05 Mflops = 353.69 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 476.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00134676; expected ratio = 0.0001obtained abs = 1.6893e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107673; expected ratio = 0.001obtained abs = 37.5343; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.753730e+05 Mflops = 353.47 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000275373; expected ratio = 0.0001obtained abs = 3.45412e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0796565; expected ratio = 0.001obtained abs = 27.6333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.743890e+05 Mflops = 353.01 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 473.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000219051; expected ratio = 0.0001obtained abs = 2.74764e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.100493; expected ratio = 0.001obtained abs = 35.7627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.743890e+05 Mflops = 353.01 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 486.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000207779; expected ratio = 0.0001obtained abs = 2.60626e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0653191; expected ratio = 0.001obtained abs = 23.1296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.743890e+05 Mflops = 353.69 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 490.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000827943; expected ratio = 0.0001obtained abs = 1.03851e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0641093; expected ratio = 0.001obtained abs = 22.4251; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.740950e+05 Mflops = 353.95 -Solve time = 0.00 -Solve flops = 1.611000e+04 Mflops = 486.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00100071; expected ratio = 0.0001obtained abs = 1.25524e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.069574; expected ratio = 0.001obtained abs = 24.0945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.743890e+05 Mflops = 353.69 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 473.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000645359; expected ratio = 0.0001obtained abs = 8.09501e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103827; expected ratio = 0.001obtained abs = 36.8005; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.740890e+05 Mflops = 353.09 -Solve time = 0.00 -Solve flops = 1.611200e+04 Mflops = 472.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000279621; expected ratio = 0.0001obtained abs = 3.50741e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0998969; expected ratio = 0.001obtained abs = 35.8819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.743890e+05 Mflops = 354.55 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 486.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000134766; expected ratio = 0.0001obtained abs = 1.69043e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0908663; expected ratio = 0.001obtained abs = 31.8123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.743290e+05 Mflops = 344.58 -Solve time = 0.00 -Solve flops = 1.612800e+04 Mflops = 412.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.92073e-05; expected ratio = 0.0001obtained abs = 1.11896e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0563088; expected ratio = 0.001obtained abs = 19.5205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.0532 - Final Residual ratio : 0.0176537 - Residual ratio : 0.000838526 - Slope : -1.05178 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.1512 - Final Residual ratio : 0.0176957 - Residual ratio : 0.000924 - Slope : -0.637785 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2781 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.6121 - Final Residual ratio : 0.0146877 - Residual ratio : 0.000884157 - Slope : -0.572326 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.175 - Final Residual ratio : 0.0113307 - Residual ratio : 0.000799345 - Slope : -0.505846 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.3409 - Final Residual ratio : 0.0263699 - Residual ratio : 0.00089874 - Slope : -1.08572 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 102.835 - Final Residual ratio : 0.0962181 - Residual ratio : 0.000935652 - Slope : -3.95151 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.6708 - Final Residual ratio : 0.0458928 - Residual ratio : 0.000942924 - Slope : -1.67672 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.6372 - Final Residual ratio : 0.0125595 - Residual ratio : 0.000993851 - Slope : -0.420822 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.7597 - Final Residual ratio : 0.0108469 - Residual ratio : 0.00092238 - Slope : -0.378997 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.1591 - Final Residual ratio : 0.00931012 - Residual ratio : 0.000834311 - Slope : -0.359669 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 12 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2851 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.810040e+05 Mflops = 360.66 -Solve time = 0.00 -Solve flops = 1.645600e+04 Mflops = 469.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0798445; expected ratio = 0.0001obtained abs = 0.00100784; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0940797; expected ratio = 0.001obtained abs = 32.5913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.813460e+05 Mflops = 364.11 -Solve time = 0.00 -Solve flops = 1.647600e+04 Mflops = 483.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00930975; expected ratio = 0.0001obtained abs = 0.000117422; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0946743; expected ratio = 0.001obtained abs = 33.1314; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.813460e+05 Mflops = 363.41 -Solve time = 0.00 -Solve flops = 1.647600e+04 Mflops = 500.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00096429; expected ratio = 0.0001obtained abs = 1.21633e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0859094; expected ratio = 0.001obtained abs = 29.4749; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.815020e+05 Mflops = 364.42 -Solve time = 0.00 -Solve flops = 1.648400e+04 Mflops = 501.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000131922; expected ratio = 0.0001obtained abs = 1.66401e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0538962; expected ratio = 0.001obtained abs = 18.4461; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.818080e+05 Mflops = 364.34 -Solve time = 0.00 -Solve flops = 1.650200e+04 Mflops = 501.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00011295; expected ratio = 0.0001obtained abs = 1.42471e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0656126; expected ratio = 0.001obtained abs = 22.699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.815020e+05 Mflops = 365.12 -Solve time = 0.00 -Solve flops = 1.648400e+04 Mflops = 486.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000182409; expected ratio = 0.0001obtained abs = 2.30085e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0601784; expected ratio = 0.001obtained abs = 20.7042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.813460e+05 Mflops = 363.41 -Solve time = 0.00 -Solve flops = 1.647600e+04 Mflops = 486.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000278989; expected ratio = 0.0001obtained abs = 3.51906e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0708289; expected ratio = 0.001obtained abs = 24.3213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.818420e+05 Mflops = 364.41 -Solve time = 0.00 -Solve flops = 1.650400e+04 Mflops = 366.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000275652; expected ratio = 0.0001obtained abs = 3.47697e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.085042; expected ratio = 0.001obtained abs = 29.1798; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000428915 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.802330e+05 Mflops = 357.59 -Solve time = 0.00 -Solve flops = 1.641800e+04 Mflops = 481.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.58979e-05; expected ratio = 0.0001obtained abs = 9.57351e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0868371; expected ratio = 0.001obtained abs = 29.9973; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.88781 - Final Residual ratio : 0.00988234 - Residual ratio : 0.000999446 - Slope : -0.329264 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2871 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.711 - Final Residual ratio : 0.00761985 - Residual ratio : 0.000874739 - Slope : -0.458073 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2871 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2881 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.84904 - Final Residual ratio : 0.00763332 - Residual ratio : 0.000972516 - Slope : -0.28005 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2881 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2891 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.20713 - Final Residual ratio : 0.00431767 - Residual ratio : 0.000599083 - Slope : -0.240094 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2891 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2901 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.66529 - Final Residual ratio : 0.0054512 - Residual ratio : 0.000817849 - Slope : -0.22965 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2901 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2911 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.0351 - Final Residual ratio : 0.00579338 - Residual ratio : 0.000959947 - Slope : -0.223308 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2911 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2921 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.45492 - Final Residual ratio : 0.00515541 - Residual ratio : 0.000945094 - Slope : -0.201843 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2931 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.95933 - Final Residual ratio : 0.00415604 - Residual ratio : 0.000838025 - Slope : -0.183525 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2931 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2941 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.56252 - Final Residual ratio : 0.00427914 - Residual ratio : 0.00093789 - Slope : -0.227912 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2941 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2951 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.2872 - Final Residual ratio : 0.00385905 - Residual ratio : 0.000900131 - Slope : -0.214167 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2951 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.2951 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 9 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.2951 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.805900e+05 Mflops = 361.21 -Solve time = 0.00 -Solve flops = 1.647200e+04 Mflops = 483.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0782545; expected ratio = 0.0001obtained abs = 0.000997368; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0750993; expected ratio = 0.001obtained abs = 25.8277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.776350e+05 Mflops = 364.15 -Solve time = 0.00 -Solve flops = 1.633400e+04 Mflops = 479.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00764855; expected ratio = 0.0001obtained abs = 9.73626e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0501889; expected ratio = 0.001obtained abs = 17.271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.792310e+05 Mflops = 361.24 -Solve time = 0.00 -Solve flops = 1.640200e+04 Mflops = 484.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000840995; expected ratio = 0.0001obtained abs = 1.07068e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0585432; expected ratio = 0.001obtained abs = 20.1376; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.792310e+05 Mflops = 361.24 -Solve time = 0.00 -Solve flops = 1.640200e+04 Mflops = 484.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000121693; expected ratio = 0.0001obtained abs = 1.54927e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0879922; expected ratio = 0.001obtained abs = 30.6611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.792310e+05 Mflops = 360.55 -Solve time = 0.00 -Solve flops = 1.640200e+04 Mflops = 498.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000126797; expected ratio = 0.0001obtained abs = 1.61425e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.070709; expected ratio = 0.001obtained abs = 24.431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.790750e+05 Mflops = 360.24 -Solve time = 0.00 -Solve flops = 1.639400e+04 Mflops = 484.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.58188e-05; expected ratio = 0.0001obtained abs = 7.10629e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0576091; expected ratio = 0.001obtained abs = 19.785; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.2961 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.94664 - Final Residual ratio : 0.00213335 - Residual ratio : 0.000540548 - Slope : -0.1127 - Tolerance : 0.001 - Number of iterations : 35 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2961 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2971 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.6648 - Final Residual ratio : 0.00320203 - Residual ratio : 0.000873726 - Slope : -0.101711 - Tolerance : 0.001 - Number of iterations : 36 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2971 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2981 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.43238 - Final Residual ratio : 0.00338355 - Residual ratio : 0.000985772 - Slope : -0.131884 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2981 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.2991 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.23431 - Final Residual ratio : 0.00269643 - Residual ratio : 0.000833694 - Slope : -0.111435 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.2991 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3001 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.12933 - Final Residual ratio : 0.00208293 - Residual ratio : 0.000665616 - Slope : -0.120279 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3001 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3011 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.92271 - Final Residual ratio : 0.00184173 - Residual ratio : 0.000630145 - Slope : -0.100719 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3011 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.77587 - Final Residual ratio : 0.00222985 - Residual ratio : 0.000803298 - Slope : -0.0956428 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.66045 - Final Residual ratio : 0.00202049 - Residual ratio : 0.000759452 - Slope : -0.094944 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3031 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3041 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.57371 - Final Residual ratio : 0.00216836 - Residual ratio : 0.000842506 - Slope : -0.0952421 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3041 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3051 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.5683 - Final Residual ratio : 0.00230877 - Residual ratio : 0.000898948 - Slope : -0.0950366 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3051 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.3051 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 113 - - Mesh vertices: 110 - Mesh triangles: 113 - Mesh edges: 186 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.3051 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.797250e+05 Mflops = 359.48 -Solve time = 0.00 -Solve flops = 1.641800e+04 Mflops = 481.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.110004; expected ratio = 0.0001obtained abs = 0.00140486; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.16383; expected ratio = 0.001obtained abs = 54.5782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.789470e+05 Mflops = 359.98 -Solve time = 0.00 -Solve flops = 1.639600e+04 Mflops = 498.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00819999; expected ratio = 0.0001obtained abs = 0.000104575; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121161; expected ratio = 0.001obtained abs = 40.6083; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000409126 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.784510e+05 Mflops = 369.44 -Solve time = 0.00 -Solve flops = 1.636800e+04 Mflops = 483.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000801225; expected ratio = 0.0001obtained abs = 1.02197e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0859479; expected ratio = 0.001obtained abs = 28.2487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000407934 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.790470e+05 Mflops = 361.74 -Solve time = 0.00 -Solve flops = 1.640200e+04 Mflops = 481.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000100625; expected ratio = 0.0001obtained abs = 1.28347e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0634887; expected ratio = 0.001obtained abs = 20.7252; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000408173 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.787570e+05 Mflops = 369.34 -Solve time = 0.00 -Solve flops = 1.638600e+04 Mflops = 494.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000183099; expected ratio = 0.0001obtained abs = 2.33542e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0759471; expected ratio = 0.001obtained abs = 25.2253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406981 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.784510e+05 Mflops = 360.54 -Solve time = 0.00 -Solve flops = 1.636800e+04 Mflops = 497.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000224606; expected ratio = 0.0001obtained abs = 2.86484e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0734954; expected ratio = 0.001obtained abs = 24.2936; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,113) -time: 0.000406027 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.784510e+05 Mflops = 368.71 -Solve time = 0.00 -Solve flops = 1.636800e+04 Mflops = 493.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.31633e-05; expected ratio = 0.0001obtained abs = 9.33193e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0874419; expected ratio = 0.001obtained abs = 28.7799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.3061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.1755 - Final Residual ratio : 0.011573 - Residual ratio : 0.000950515 - Slope : -0.434428 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3061 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.04256 - Final Residual ratio : 0.0072682 - Residual ratio : 0.000803776 - Slope : -0.311562 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3071 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.28306 - Final Residual ratio : 0.00919717 - Residual ratio : 0.000990747 - Slope : -0.319788 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3081 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3091 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.21983 - Final Residual ratio : 0.00737491 - Residual ratio : 0.000897209 - Slope : -0.283188 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3091 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3101 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.00759 - Final Residual ratio : 0.0063341 - Residual ratio : 0.000903892 - Slope : -0.259306 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3101 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3111 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.89743 - Final Residual ratio : 0.00486202 - Residual ratio : 0.000824431 - Slope : -0.218243 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3111 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3121 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.15898 - Final Residual ratio : 0.00448859 - Residual ratio : 0.000870055 - Slope : -0.19825 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3131 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.67317 - Final Residual ratio : 0.0039101 - Residual ratio : 0.000836712 - Slope : -0.179587 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3131 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3141 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.30253 - Final Residual ratio : 0.0031705 - Residual ratio : 0.000736893 - Slope : -0.16536 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3141 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3151 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.04718 - Final Residual ratio : 0.00331453 - Residual ratio : 0.000818973 - Slope : -0.155533 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3151 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.3151 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 113 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.3151 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.800140e+05 Mflops = 361.43 -Solve time = 0.00 -Solve flops = 1.638000e+04 Mflops = 480.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.087186; expected ratio = 0.0001obtained abs = 0.0011208; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.198484; expected ratio = 0.001obtained abs = 74.5819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.811790e+05 Mflops = 365.17 -Solve time = 0.00 -Solve flops = 1.644000e+04 Mflops = 485.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0122716; expected ratio = 0.0001obtained abs = 0.000157504; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0416017; expected ratio = 0.001obtained abs = 15.8374; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.811790e+05 Mflops = 364.64 -Solve time = 0.00 -Solve flops = 1.644000e+04 Mflops = 496.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00213036; expected ratio = 0.0001obtained abs = 2.73472e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.031136; expected ratio = 0.001obtained abs = 11.8668; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.811790e+05 Mflops = 355.93 -Solve time = 0.00 -Solve flops = 1.644000e+04 Mflops = 499.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000409673; expected ratio = 0.0001obtained abs = 5.25894e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.027132; expected ratio = 0.001obtained abs = 10.2894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.811790e+05 Mflops = 365.17 -Solve time = 0.00 -Solve flops = 1.644000e+04 Mflops = 485.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.46924e-05; expected ratio = 0.0001obtained abs = 1.21557e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0178504; expected ratio = 0.001obtained abs = 6.77505; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.3161 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.51167 - Final Residual ratio : 0.00447569 - Residual ratio : 0.000992026 - Slope : -0.346707 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3161 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3171 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.6389 - Final Residual ratio : 0.025676 - Residual ratio : 0.000682166 - Slope : -1.25377 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3171 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3181 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.3584 - Final Residual ratio : 0.0115929 - Residual ratio : 0.000867838 - Slope : -0.513337 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3181 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3191 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.54567 - Final Residual ratio : 0.00504706 - Residual ratio : 0.000771053 - Slope : -0.210988 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3191 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.98008 - Final Residual ratio : 0.00418141 - Residual ratio : 0.000699223 - Slope : -0.199197 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3201 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3211 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.71594 - Final Residual ratio : 0.00502758 - Residual ratio : 0.000748604 - Slope : -0.223697 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3211 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.80763 - Final Residual ratio : 0.00613167 - Residual ratio : 0.000900706 - Slope : -0.219403 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3231 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.23642 - Final Residual ratio : 0.00556536 - Residual ratio : 0.000892396 - Slope : -0.207695 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3231 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3241 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.52799 - Final Residual ratio : 0.00444686 - Residual ratio : 0.000804427 - Slope : -0.230147 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3241 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3251 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.16217 - Final Residual ratio : 0.00469834 - Residual ratio : 0.000910149 - Slope : -0.184195 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3251 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.3251 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.3251 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.538800e+05 Mflops = 332.35 -Solve time = 0.00 -Solve flops = 1.530400e+04 Mflops = 479.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0709756; expected ratio = 0.0001obtained abs = 0.000918673; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.242097; expected ratio = 0.001obtained abs = 77.9259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547060e+05 Mflops = 334.82 -Solve time = 0.00 -Solve flops = 1.535400e+04 Mflops = 463.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0119882; expected ratio = 0.0001obtained abs = 0.000154861; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0834203; expected ratio = 0.001obtained abs = 27.1255; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547060e+05 Mflops = 329.89 -Solve time = 0.00 -Solve flops = 1.535400e+04 Mflops = 480.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00240715; expected ratio = 0.0001obtained abs = 3.1089e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0632427; expected ratio = 0.001obtained abs = 20.8541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547060e+05 Mflops = 333.45 -Solve time = 0.00 -Solve flops = 1.535400e+04 Mflops = 480.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000468448; expected ratio = 0.0001obtained abs = 6.04983e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.062413; expected ratio = 0.001obtained abs = 20.268; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547060e+05 Mflops = 334.82 -Solve time = 0.00 -Solve flops = 1.535400e+04 Mflops = 466.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000136306; expected ratio = 0.0001obtained abs = 1.76031e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0377223; expected ratio = 0.001obtained abs = 12.181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547060e+05 Mflops = 333.45 -Solve time = 0.00 -Solve flops = 1.535400e+04 Mflops = 463.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000126725; expected ratio = 0.0001obtained abs = 1.63659e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0369624; expected ratio = 0.001obtained abs = 11.9259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547060e+05 Mflops = 334.13 -Solve time = 0.00 -Solve flops = 1.535400e+04 Mflops = 480.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000193819; expected ratio = 0.0001obtained abs = 2.50306e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0428305; expected ratio = 0.001obtained abs = 13.8218; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547060e+05 Mflops = 334.82 -Solve time = 0.00 -Solve flops = 1.535400e+04 Mflops = 480.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000195721; expected ratio = 0.0001obtained abs = 2.52761e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0453312; expected ratio = 0.001obtained abs = 14.6437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000419855 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547060e+05 Mflops = 334.13 -Solve time = 0.00 -Solve flops = 1.535400e+04 Mflops = 480.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.79096e-05; expected ratio = 0.0001obtained abs = 6.18725e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.039509; expected ratio = 0.001obtained abs = 12.7396; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.3261 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1131 - Final Residual ratio : 0.00825316 - Residual ratio : 0.000816086 - Slope : -0.336828 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3261 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3271 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.2826 - Final Residual ratio : 0.0668062 - Residual ratio : 0.000992919 - Slope : -2.40056 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3271 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3281 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.2118 - Final Residual ratio : 0.0195482 - Residual ratio : 0.000775358 - Slope : -1.09532 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3281 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3291 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.2711 - Final Residual ratio : 0.00911295 - Residual ratio : 0.00063856 - Slope : -0.491792 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3291 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 4.3301 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.933 - Final Residual ratio : 0.00859608 - Residual ratio : 0.000786248 - Slope : -0.390159 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3301 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3311 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.92471 - Final Residual ratio : 0.00810142 - Residual ratio : 0.000816288 - Slope : -0.319891 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3311 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3321 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.12585 - Final Residual ratio : 0.0078866 - Residual ratio : 0.000864205 - Slope : -0.303932 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3331 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.9953 - Final Residual ratio : 0.00505975 - Residual ratio : 0.000632841 - Slope : -0.25775 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3331 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3341 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.77309 - Final Residual ratio : 0.0065128 - Residual ratio : 0.00096157 - Slope : -0.218277 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3341 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3351 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.94862 - Final Residual ratio : 0.00461911 - Residual ratio : 0.000776502 - Slope : -0.204965 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3351 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.3351 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 9 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.3351 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547060e+05 Mflops = 332.76 -Solve time = 0.00 -Solve flops = 1.535400e+04 Mflops = 463.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0707636; expected ratio = 0.0001obtained abs = 0.000921101; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.149999; expected ratio = 0.001obtained abs = 54.5578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.541500e+05 Mflops = 335.17 -Solve time = 0.00 -Solve flops = 1.532200e+04 Mflops = 476.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0119837; expected ratio = 0.0001obtained abs = 0.000155784; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0201127; expected ratio = 0.001obtained abs = 7.35753; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.541500e+05 Mflops = 335.00 -Solve time = 0.00 -Solve flops = 1.532200e+04 Mflops = 465.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00187951; expected ratio = 0.0001obtained abs = 2.44336e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00874238; expected ratio = 0.001obtained abs = 3.19509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.541500e+05 Mflops = 335.17 -Solve time = 0.00 -Solve flops = 1.532200e+04 Mflops = 476.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000494293; expected ratio = 0.0001obtained abs = 6.42584e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00488914; expected ratio = 0.001obtained abs = 1.78764; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.541500e+05 Mflops = 335.00 -Solve time = 0.00 -Solve flops = 1.532200e+04 Mflops = 479.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000140501; expected ratio = 0.0001obtained abs = 1.82652e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00395678; expected ratio = 0.001obtained abs = 1.44783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.541500e+05 Mflops = 334.31 -Solve time = 0.00 -Solve flops = 1.532200e+04 Mflops = 479.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.75404e-05; expected ratio = 0.0001obtained abs = 6.1803e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00416934; expected ratio = 0.001obtained abs = 1.52578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.3361 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.62896 - Final Residual ratio : 0.00450094 - Residual ratio : 0.000799604 - Slope : -0.181434 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3361 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3371 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.48643 - Final Residual ratio : 0.00382411 - Residual ratio : 0.000697013 - Slope : -0.16614 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3371 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3381 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.11609 - Final Residual ratio : 0.00353494 - Residual ratio : 0.000690946 - Slope : -0.159767 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3381 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3391 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48479 - Final Residual ratio : 0.0029225 - Residual ratio : 0.000651648 - Slope : -0.149396 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3391 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3401 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.92596 - Final Residual ratio : 0.00289276 - Residual ratio : 0.000736828 - Slope : -0.122596 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3401 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3411 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.70455 - Final Residual ratio : 0.00294923 - Residual ratio : 0.000796109 - Slope : -0.123387 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3411 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3421 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.82291 - Final Residual ratio : 0.00275848 - Residual ratio : 0.000721564 - Slope : -0.11938 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3431 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.89193 - Final Residual ratio : 0.00347685 - Residual ratio : 0.00089335 - Slope : -0.125434 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3431 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3441 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.70033 - Final Residual ratio : 0.00242603 - Residual ratio : 0.000655626 - Slope : -0.119287 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3441 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3451 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36275 - Final Residual ratio : 0.00316686 - Residual ratio : 0.000941748 - Slope : -0.119985 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3451 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.3451 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.3451 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.542520e+05 Mflops = 333.15 -Solve time = 0.00 -Solve flops = 1.532800e+04 Mflops = 462.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0663308; expected ratio = 0.0001obtained abs = 0.000871056; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11551; expected ratio = 0.001obtained abs = 38.5033; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.544000e+05 Mflops = 334.16 -Solve time = 0.00 -Solve flops = 1.533800e+04 Mflops = 480.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00917264; expected ratio = 0.0001obtained abs = 0.000120412; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0753358; expected ratio = 0.001obtained abs = 25.3195; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000431061 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.72 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 466.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0018325; expected ratio = 0.0001obtained abs = 2.40575e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0588946; expected ratio = 0.001obtained abs = 20.0368; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.03 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 466.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000460679; expected ratio = 0.0001obtained abs = 6.04804e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0551744; expected ratio = 0.001obtained abs = 18.5535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.20 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 462.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000187627; expected ratio = 0.0001obtained abs = 2.46327e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0719172; expected ratio = 0.001obtained abs = 23.8287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000418901 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.536500e+05 Mflops = 333.40 -Solve time = 0.00 -Solve flops = 1.530200e+04 Mflops = 475.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000674817; expected ratio = 0.0001obtained abs = 8.85936e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0985878; expected ratio = 0.001obtained abs = 33.0959; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.89 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 479.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000824419; expected ratio = 0.0001obtained abs = 1.08233e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.108749; expected ratio = 0.001obtained abs = 37.4978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000419855 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 327.77 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 479.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000449887; expected ratio = 0.0001obtained abs = 5.90636e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.130954; expected ratio = 0.001obtained abs = 43.633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.551320e+05 Mflops = 334.36 -Solve time = 0.00 -Solve flops = 1.538200e+04 Mflops = 481.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000154922; expected ratio = 0.0001obtained abs = 2.0339e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.063345; expected ratio = 0.001obtained abs = 21.0732; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.72 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 479.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00017001; expected ratio = 0.0001obtained abs = 2.23198e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.07107; expected ratio = 0.001obtained abs = 24.0036; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.72 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 479.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000152357; expected ratio = 0.0001obtained abs = 2.00025e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0517774; expected ratio = 0.001obtained abs = 17.4354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.03 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 479.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000486021; expected ratio = 0.0001obtained abs = 6.3808e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0389554; expected ratio = 0.001obtained abs = 13.0264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.72 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 479.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000578803; expected ratio = 0.0001obtained abs = 7.59874e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0510826; expected ratio = 0.001obtained abs = 16.9566; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.03 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 479.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00040709; expected ratio = 0.0001obtained abs = 5.34447e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0881545; expected ratio = 0.001obtained abs = 29.6874; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 334.72 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 466.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000255086; expected ratio = 0.0001obtained abs = 3.34893e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0923426; expected ratio = 0.001obtained abs = 31.4108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.543400e+05 Mflops = 329.10 -Solve time = 0.00 -Solve flops = 1.533400e+04 Mflops = 462.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.91531e-05; expected ratio = 0.0001obtained abs = 1.17046e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0868134; expected ratio = 0.001obtained abs = 28.9113; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.3461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.05721 - Final Residual ratio : 0.0025582 - Residual ratio : 0.000836776 - Slope : -0.0954579 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3461 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3471 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.04262 - Final Residual ratio : 0.00280388 - Residual ratio : 0.000921535 - Slope : -0.101327 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3471 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3481 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.13478 - Final Residual ratio : 0.00228158 - Residual ratio : 0.000727828 - Slope : -0.104417 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3481 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3491 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.09188 - Final Residual ratio : 0.00300403 - Residual ratio : 0.000971587 - Slope : -0.0965273 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3491 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3501 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.86868 - Final Residual ratio : 0.00188647 - Residual ratio : 0.00065761 - Slope : -0.0924772 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3501 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3511 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.50538 - Final Residual ratio : 0.00205905 - Residual ratio : 0.000821852 - Slope : -0.0894043 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3511 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3521 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.31911 - Final Residual ratio : 0.00211119 - Residual ratio : 0.000910346 - Slope : -0.0798964 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3531 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.37059 - Final Residual ratio : 0.00184221 - Residual ratio : 0.00077711 - Slope : -0.0740235 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3531 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3541 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.47498 - Final Residual ratio : 0.00183291 - Residual ratio : 0.000740575 - Slope : -0.077286 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3541 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3551 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.48909 - Final Residual ratio : 0.00152982 - Residual ratio : 0.000614613 - Slope : -0.0802438 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3551 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.3551 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 16 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.3551 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.529340e+05 Mflops = 328.11 -Solve time = 0.00 -Solve flops = 1.525200e+04 Mflops = 463.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0659688; expected ratio = 0.0001obtained abs = 0.000878401; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0944631; expected ratio = 0.001obtained abs = 33.4438; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.522020e+05 Mflops = 326.70 -Solve time = 0.00 -Solve flops = 1.520800e+04 Mflops = 476.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00722062; expected ratio = 0.0001obtained abs = 9.59993e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0585207; expected ratio = 0.001obtained abs = 21.0112; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.522020e+05 Mflops = 320.47 -Solve time = 0.00 -Solve flops = 1.520800e+04 Mflops = 472.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00143094; expected ratio = 0.0001obtained abs = 1.90274e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.029934; expected ratio = 0.001obtained abs = 10.6696; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000424147 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.522020e+05 Mflops = 328.05 -Solve time = 0.00 -Solve flops = 1.520800e+04 Mflops = 476.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000343016; expected ratio = 0.0001obtained abs = 4.5611e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0338759; expected ratio = 0.001obtained abs = 12.0227; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.522020e+05 Mflops = 328.72 -Solve time = 0.00 -Solve flops = 1.520800e+04 Mflops = 476.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.92312e-05; expected ratio = 0.0001obtained abs = 1.05355e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0339342; expected ratio = 0.001obtained abs = 12.1232; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.3561 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.1615 - Final Residual ratio : 0.0137604 - Residual ratio : 0.000971676 - Slope : -0.487853 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3561 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3571 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.3432 - Final Residual ratio : 0.0197728 - Residual ratio : 0.000723135 - Slope : -1.0509 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3571 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.1588 - Final Residual ratio : 0.0312204 - Residual ratio : 0.000970821 - Slope : -1.69092 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3581 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3591 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.76938 - Final Residual ratio : 0.00402611 - Residual ratio : 0.000844158 - Slope : -0.176495 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3591 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3601 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.34977 - Final Residual ratio : 0.00397547 - Residual ratio : 0.00074311 - Slope : -0.184338 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3601 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3611 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.87187 - Final Residual ratio : 0.00549916 - Residual ratio : 0.000936525 - Slope : -0.202289 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3611 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.38283 - Final Residual ratio : 0.00497337 - Residual ratio : 0.000923933 - Slope : -0.185443 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3631 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3546 - Final Residual ratio : 0.00727022 - Residual ratio : 0.000702126 - Slope : -0.413892 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3631 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3641 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.0179 - Final Residual ratio : 0.0201364 - Residual ratio : 0.000914546 - Slope : -0.785634 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3641 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.5441 - Final Residual ratio : 0.0203189 - Residual ratio : 0.000737686 - Slope : -1.05861 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3651 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.3651 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.3651 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.513020e+05 Mflops = 324.77 -Solve time = 0.00 -Solve flops = 1.515800e+04 Mflops = 457.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0652453; expected ratio = 0.0001obtained abs = 0.000883186; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0559885; expected ratio = 0.001obtained abs = 19.3306; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.513020e+05 Mflops = 327.62 -Solve time = 0.00 -Solve flops = 1.515800e+04 Mflops = 470.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00650685; expected ratio = 0.0001obtained abs = 8.80233e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0531321; expected ratio = 0.001obtained abs = 18.3563; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.513020e+05 Mflops = 327.62 -Solve time = 0.00 -Solve flops = 1.515800e+04 Mflops = 489.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117195; expected ratio = 0.0001obtained abs = 1.58577e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0548735; expected ratio = 0.001obtained abs = 18.9503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.513020e+05 Mflops = 327.45 -Solve time = 0.00 -Solve flops = 1.515800e+04 Mflops = 474.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000423925; expected ratio = 0.0001obtained abs = 5.73637e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0429573; expected ratio = 0.001obtained abs = 14.8114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.518980e+05 Mflops = 321.77 -Solve time = 0.00 -Solve flops = 1.519200e+04 Mflops = 461.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000134952; expected ratio = 0.0001obtained abs = 1.82613e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.057776; expected ratio = 0.001obtained abs = 19.8643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.513020e+05 Mflops = 327.45 -Solve time = 0.00 -Solve flops = 1.515800e+04 Mflops = 474.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.85566e-05; expected ratio = 0.0001obtained abs = 6.57053e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0832744; expected ratio = 0.001obtained abs = 29.0394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.3661 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.73781 - Final Residual ratio : 0.00269783 - Residual ratio : 0.000569426 - Slope : -0.157837 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3661 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3671 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.38636 - Final Residual ratio : 0.00366651 - Residual ratio : 0.000574115 - Slope : -0.220093 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3671 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3681 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.47999 - Final Residual ratio : 0.00538424 - Residual ratio : 0.000830902 - Slope : -0.223262 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3681 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3691 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.77932 - Final Residual ratio : 0.00408411 - Residual ratio : 0.000706676 - Slope : -0.222125 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3691 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3701 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.93979 - Final Residual ratio : 0.00383529 - Residual ratio : 0.000776409 - Slope : -0.182813 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3701 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3711 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.3633 - Final Residual ratio : 0.00268994 - Residual ratio : 0.000616491 - Slope : -0.145354 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3711 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3721 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.86388 - Final Residual ratio : 0.00257988 - Residual ratio : 0.000667691 - Slope : -0.12871 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3731 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.45227 - Final Residual ratio : 0.00247991 - Residual ratio : 0.000718342 - Slope : -0.118958 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3731 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3741 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11092 - Final Residual ratio : 0.00235851 - Residual ratio : 0.000758139 - Slope : -0.11102 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3741 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3751 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.80655 - Final Residual ratio : 0.00278605 - Residual ratio : 0.000992694 - Slope : -0.116824 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3751 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.3751 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.3751 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.566900e+05 Mflops = 330.59 -Solve time = 0.00 -Solve flops = 1.545400e+04 Mflops = 466.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0657182; expected ratio = 0.0001obtained abs = 0.000910357; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0658239; expected ratio = 0.001obtained abs = 23.2835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.570800e+05 Mflops = 333.59 -Solve time = 0.00 -Solve flops = 1.548000e+04 Mflops = 484.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00764845; expected ratio = 0.0001obtained abs = 0.000105717; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0464481; expected ratio = 0.001obtained abs = 16.4197; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.570800e+05 Mflops = 332.92 -Solve time = 0.00 -Solve flops = 1.548000e+04 Mflops = 480.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00133262; expected ratio = 0.0001obtained abs = 1.84236e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0873626; expected ratio = 0.001obtained abs = 31.181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.568700e+05 Mflops = 332.98 -Solve time = 0.00 -Solve flops = 1.546600e+04 Mflops = 484.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000468356; expected ratio = 0.0001obtained abs = 6.47513e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0931763; expected ratio = 0.001obtained abs = 33.5635; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000420809 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.570800e+05 Mflops = 333.42 -Solve time = 0.00 -Solve flops = 1.548000e+04 Mflops = 484.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000175673; expected ratio = 0.0001obtained abs = 2.4287e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0583312; expected ratio = 0.001obtained abs = 20.696; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.570800e+05 Mflops = 334.27 -Solve time = 0.00 -Solve flops = 1.548000e+04 Mflops = 484.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.30494e-05; expected ratio = 0.0001obtained abs = 1.00991e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0237728; expected ratio = 0.001obtained abs = 8.41786; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.3761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.63029 - Final Residual ratio : 0.00159386 - Residual ratio : 0.000605963 - Slope : -0.0876232 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3761 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3771 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.9829 - Final Residual ratio : 0.0290552 - Residual ratio : 0.000569901 - Slope : -1.69846 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3771 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3781 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.6872 - Final Residual ratio : 0.0135748 - Residual ratio : 0.000865344 - Slope : -0.681461 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3781 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3791 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 60.1393 - Final Residual ratio : 0.0525731 - Residual ratio : 0.000874189 - Slope : -2.22543 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3791 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3801 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 76.8522 - Final Residual ratio : 0.0416279 - Residual ratio : 0.000541662 - Slope : -2.25913 - Tolerance : 0.001 - Number of iterations : 34 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3801 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3811 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 169.176 - Final Residual ratio : 0.132713 - Residual ratio : 0.000784469 - Slope : -5.82909 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3811 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3821 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.275 - Final Residual ratio : 0.0285629 - Residual ratio : 0.000709196 - Slope : -2.11823 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3831 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.2718 - Final Residual ratio : 0.0278705 - Residual ratio : 0.000952127 - Slope : -0.913873 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3831 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3841 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.6997 - Final Residual ratio : 0.031902 - Residual ratio : 0.000946654 - Slope : -1.08606 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3841 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.3851 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.783 - Final Residual ratio : 0.0194212 - Residual ratio : 0.000652088 - Slope : -0.960116 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3851 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.3851 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.3851 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.664880e+05 Mflops = 356.46 -Solve time = 0.00 -Solve flops = 1.576600e+04 Mflops = 479.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0638932; expected ratio = 0.0001obtained abs = 0.000905088; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0976729; expected ratio = 0.001obtained abs = 34.1983; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.662920e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.575200e+04 Mflops = 493.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00702457; expected ratio = 0.0001obtained abs = 9.93801e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0964945; expected ratio = 0.001obtained abs = 34.2193; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.00041914 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.658800e+05 Mflops = 357.53 -Solve time = 0.00 -Solve flops = 1.572800e+04 Mflops = 492.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000831516; expected ratio = 0.0001obtained abs = 1.17672e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.087048; expected ratio = 0.001obtained abs = 30.2591; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000430107 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.695180e+05 Mflops = 360.55 -Solve time = 0.00 -Solve flops = 1.594200e+04 Mflops = 484.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000621363; expected ratio = 0.0001obtained abs = 8.79303e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0653513; expected ratio = 0.001obtained abs = 22.5758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.662920e+05 Mflops = 357.68 -Solve time = 0.00 -Solve flops = 1.575200e+04 Mflops = 478.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129125; expected ratio = 0.0001obtained abs = 1.82727e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0916464; expected ratio = 0.001obtained abs = 32.3039; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.664880e+05 Mflops = 357.92 -Solve time = 0.00 -Solve flops = 1.576600e+04 Mflops = 479.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00177375; expected ratio = 0.0001obtained abs = 2.51013e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0654193; expected ratio = 0.001obtained abs = 23.1718; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.658800e+05 Mflops = 357.53 -Solve time = 0.00 -Solve flops = 1.572800e+04 Mflops = 478.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00105444; expected ratio = 0.0001obtained abs = 1.49218e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0645221; expected ratio = 0.001obtained abs = 22.5517; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000419855 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.663380e+05 Mflops = 356.14 -Solve time = 0.00 -Solve flops = 1.575600e+04 Mflops = 493.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000183509; expected ratio = 0.0001obtained abs = 2.59691e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.060718; expected ratio = 0.001obtained abs = 20.988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.664880e+05 Mflops = 357.37 -Solve time = 0.00 -Solve flops = 1.576600e+04 Mflops = 493.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000856879; expected ratio = 0.0001obtained abs = 1.21258e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0918828; expected ratio = 0.001obtained abs = 32.1506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.663380e+05 Mflops = 357.78 -Solve time = 0.00 -Solve flops = 1.575600e+04 Mflops = 475.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000854409; expected ratio = 0.0001obtained abs = 1.20909e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0993411; expected ratio = 0.001obtained abs = 35.1746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.658800e+05 Mflops = 358.27 -Solve time = 0.00 -Solve flops = 1.572800e+04 Mflops = 492.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000350143; expected ratio = 0.0001obtained abs = 4.95502e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0663575; expected ratio = 0.001obtained abs = 23.2828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.663380e+05 Mflops = 348.66 -Solve time = 0.00 -Solve flops = 1.575600e+04 Mflops = 478.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000219521; expected ratio = 0.0001obtained abs = 3.10654e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0704421; expected ratio = 0.001obtained abs = 24.4004; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.664880e+05 Mflops = 358.10 -Solve time = 0.00 -Solve flops = 1.576600e+04 Mflops = 493.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000851096; expected ratio = 0.0001obtained abs = 1.2044e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0973224; expected ratio = 0.001obtained abs = 34.0269; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.663380e+05 Mflops = 357.60 -Solve time = 0.00 -Solve flops = 1.575600e+04 Mflops = 493.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000869206; expected ratio = 0.0001obtained abs = 1.23003e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.110333; expected ratio = 0.001obtained abs = 38.7805; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.662920e+05 Mflops = 358.42 -Solve time = 0.00 -Solve flops = 1.575200e+04 Mflops = 493.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000347177; expected ratio = 0.0001obtained abs = 4.91304e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0852121; expected ratio = 0.001obtained abs = 29.676; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.663380e+05 Mflops = 357.60 -Solve time = 0.00 -Solve flops = 1.575600e+04 Mflops = 478.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000628939; expected ratio = 0.0001obtained abs = 8.90031e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0769623; expected ratio = 0.001obtained abs = 26.6893; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.662920e+05 Mflops = 357.68 -Solve time = 0.00 -Solve flops = 1.575200e+04 Mflops = 489.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00066522; expected ratio = 0.0001obtained abs = 9.41362e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0820028; expected ratio = 0.001obtained abs = 28.6537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.663380e+05 Mflops = 357.60 -Solve time = 0.00 -Solve flops = 1.575600e+04 Mflops = 493.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000314732; expected ratio = 0.0001obtained abs = 4.45394e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0862158; expected ratio = 0.001obtained abs = 30.0774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.656840e+05 Mflops = 356.92 -Solve time = 0.00 -Solve flops = 1.571400e+04 Mflops = 436.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000188195; expected ratio = 0.0001obtained abs = 2.66322e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0818583; expected ratio = 0.001obtained abs = 28.3978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.695180e+05 Mflops = 360.55 -Solve time = 0.00 -Solve flops = 1.594200e+04 Mflops = 484.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000208488; expected ratio = 0.0001obtained abs = 2.95042e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117016; expected ratio = 0.001obtained abs = 40.9129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.3861 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.7523 - Final Residual ratio : 0.0165782 - Residual ratio : 0.00069796 - Slope : -0.847704 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3861 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000996919316435 -******** CURRENT TIME = 4.38709691932 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.8642 - Final Residual ratio : 0.03352 - Residual ratio : 0.00086249 - Slope : -1.29436 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3871 - DELTA_TIME : 0.000996919 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000989452428264 -******** CURRENT TIME = 4.38808637174 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 87.5817 - Final Residual ratio : 0.0735342 - Residual ratio : 0.000839607 - Slope : -3.01752 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.38809 - DELTA_TIME : 0.000989452 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000981871811576 -******** CURRENT TIME = 4.38906824356 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 94.8982 - Final Residual ratio : 0.0680491 - Residual ratio : 0.000717075 - Slope : -3.16101 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.38907 - DELTA_TIME : 0.000981872 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000974466948092 -******** CURRENT TIME = 4.3900427105 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.3903 - Final Residual ratio : 0.015962 - Residual ratio : 0.00078282 - Slope : -0.679145 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39004 - DELTA_TIME : 0.000974467 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000967307054915 -******** CURRENT TIME = 4.39101001756 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.2519 - Final Residual ratio : 0.0145618 - Residual ratio : 0.000626265 - Slope : -0.801287 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39101 - DELTA_TIME : 0.000967307 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000960326765776 -******** CURRENT TIME = 4.39197034432 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.782 - Final Residual ratio : 0.020431 - Residual ratio : 0.000762862 - Slope : -0.922812 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39197 - DELTA_TIME : 0.000960327 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000953440342532 -******** CURRENT TIME = 4.39292378467 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.775 - Final Residual ratio : 0.0169832 - Residual ratio : 0.000745695 - Slope : -0.758601 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39292 - DELTA_TIME : 0.00095344 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000946604863137 -******** CURRENT TIME = 4.39387038953 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2618 - Final Residual ratio : 0.0146187 - Residual ratio : 0.000898957 - Slope : -0.541574 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39387 - DELTA_TIME : 0.000946605 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000939828858772 -******** CURRENT TIME = 4.39481021839 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0132 - Final Residual ratio : 0.00681754 - Residual ratio : 0.000567504 - Slope : -0.353129 - Tolerance : 0.001 - Number of iterations : 34 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39481 - DELTA_TIME : 0.000939829 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.39481 - DELTA_TIME : 0.00971022 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.39481 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.576360e+05 Mflops = 339.76 -Solve time = 0.00 -Solve flops = 1.548800e+04 Mflops = 467.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0614934; expected ratio = 0.0001obtained abs = 0.000893844; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.131885; expected ratio = 0.001obtained abs = 45.3395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.576820e+05 Mflops = 341.26 -Solve time = 0.00 -Solve flops = 1.549200e+04 Mflops = 470.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00626352; expected ratio = 0.0001obtained abs = 9.08e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0703391; expected ratio = 0.001obtained abs = 23.9559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.576360e+05 Mflops = 341.87 -Solve time = 0.00 -Solve flops = 1.548800e+04 Mflops = 470.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00074012; expected ratio = 0.0001obtained abs = 1.07331e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0691499; expected ratio = 0.001obtained abs = 23.395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.612500e+05 Mflops = 346.13 -Solve time = 0.00 -Solve flops = 1.570400e+04 Mflops = 491.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000798902; expected ratio = 0.0001obtained abs = 1.1585e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.132159; expected ratio = 0.001obtained abs = 45.1385; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.576820e+05 Mflops = 342.14 -Solve time = 0.00 -Solve flops = 1.549200e+04 Mflops = 467.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000853183; expected ratio = 0.0001obtained abs = 1.23722e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0971974; expected ratio = 0.001obtained abs = 33.4615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000429153 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.578320e+05 Mflops = 343.00 -Solve time = 0.00 -Solve flops = 1.550200e+04 Mflops = 471.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000348896; expected ratio = 0.0001obtained abs = 5.05953e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0275647; expected ratio = 0.001obtained abs = 9.42748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.578320e+05 Mflops = 342.47 -Solve time = 0.00 -Solve flops = 1.550200e+04 Mflops = 467.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000100759; expected ratio = 0.0001obtained abs = 1.46115e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0370627; expected ratio = 0.001obtained abs = 12.6014; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.576820e+05 Mflops = 329.20 -Solve time = 0.00 -Solve flops = 1.549200e+04 Mflops = 470.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.53639e-05; expected ratio = 0.0001obtained abs = 5.12829e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0269646; expected ratio = 0.001obtained abs = 9.13353; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000933154912638 -******** CURRENT TIME = 4.3957433733 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.0978 - Final Residual ratio : 0.00772804 - Residual ratio : 0.000696359 - Slope : -0.382416 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39574 - DELTA_TIME : 0.000933155 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000926633541123 -******** CURRENT TIME = 4.39667000684 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.2897 - Final Residual ratio : 0.0100567 - Residual ratio : 0.000977351 - Slope : -0.354471 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39667 - DELTA_TIME : 0.000926634 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000920289835073 -******** CURRENT TIME = 4.39759029668 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.44437 - Final Residual ratio : 0.00690813 - Residual ratio : 0.000818075 - Slope : -0.272176 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39759 - DELTA_TIME : 0.00092029 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000914121290853 -******** CURRENT TIME = 4.39850441797 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.89065 - Final Residual ratio : 0.00553289 - Residual ratio : 0.000802956 - Slope : -0.202504 - Tolerance : 0.001 - Number of iterations : 34 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.3985 - DELTA_TIME : 0.000914121 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000908104133809 -******** CURRENT TIME = 4.3994125221 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.4416 - Final Residual ratio : 0.00610665 - Residual ratio : 0.000948001 - Slope : -0.221914 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.39941 - DELTA_TIME : 0.000908104 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000902207663918 -******** CURRENT TIME = 4.40031472977 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.11454 - Final Residual ratio : 0.00563931 - Residual ratio : 0.000922279 - Slope : -0.210652 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40031 - DELTA_TIME : 0.000902208 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000896414099498 -******** CURRENT TIME = 4.40121114387 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.18184 - Final Residual ratio : 0.00393829 - Residual ratio : 0.000760017 - Slope : -0.161809 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40121 - DELTA_TIME : 0.000896414 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000890712977009 -******** CURRENT TIME = 4.40210185684 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48554 - Final Residual ratio : 0.0042999 - Residual ratio : 0.000958613 - Slope : -0.172355 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.4021 - DELTA_TIME : 0.000890713 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000885108887234 -******** CURRENT TIME = 4.40298696573 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.64338 - Final Residual ratio : 0.00410356 - Residual ratio : 0.000883744 - Slope : -0.154643 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40299 - DELTA_TIME : 0.000885109 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000879615339119 -******** CURRENT TIME = 4.40386658107 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.78171 - Final Residual ratio : 0.00314751 - Residual ratio : 0.000658239 - Slope : -0.159286 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40387 - DELTA_TIME : 0.000879615 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.40387 - DELTA_TIME : 0.00905636 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 187 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.40387 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.604160e+05 Mflops = 342.76 -Solve time = 0.00 -Solve flops = 1.565400e+04 Mflops = 459.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0568323; expected ratio = 0.0001obtained abs = 0.000845817; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104008; expected ratio = 0.001obtained abs = 36.2237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.576360e+05 Mflops = 341.87 -Solve time = 0.00 -Solve flops = 1.548800e+04 Mflops = 470.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00559639; expected ratio = 0.0001obtained abs = 8.31338e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102764; expected ratio = 0.001obtained abs = 36.3383; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.576360e+05 Mflops = 341.87 -Solve time = 0.00 -Solve flops = 1.548800e+04 Mflops = 470.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000651399; expected ratio = 0.0001obtained abs = 9.67898e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102206; expected ratio = 0.001obtained abs = 35.113; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.608620e+05 Mflops = 344.41 -Solve time = 0.00 -Solve flops = 1.567800e+04 Mflops = 476.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000148444; expected ratio = 0.0001obtained abs = 2.20568e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0602362; expected ratio = 0.001obtained abs = 20.6502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.576360e+05 Mflops = 342.05 -Solve time = 0.00 -Solve flops = 1.548800e+04 Mflops = 467.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000111453; expected ratio = 0.0001obtained abs = 1.65603e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0786385; expected ratio = 0.001obtained abs = 27.4271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.578320e+05 Mflops = 341.59 -Solve time = 0.00 -Solve flops = 1.550200e+04 Mflops = 471.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00017375; expected ratio = 0.0001obtained abs = 2.5817e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0714234; expected ratio = 0.001obtained abs = 24.7162; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.576360e+05 Mflops = 342.05 -Solve time = 0.00 -Solve flops = 1.548800e+04 Mflops = 467.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.19533e-05; expected ratio = 0.0001obtained abs = 9.20541e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0709124; expected ratio = 0.001obtained abs = 24.4401; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000874244019346 -******** CURRENT TIME = 4.40474082509 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.39989 - Final Residual ratio : 0.0037638 - Residual ratio : 0.00085543 - Slope : -0.14181 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40474 - DELTA_TIME : 0.000874244 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000869004244515 -******** CURRENT TIME = 4.40560982933 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.74046 - Final Residual ratio : 0.0029703 - Residual ratio : 0.000794098 - Slope : -0.120564 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40561 - DELTA_TIME : 0.000869004 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000863886111696 -******** CURRENT TIME = 4.40647371545 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.43199 - Final Residual ratio : 0.00259433 - Residual ratio : 0.000755925 - Slope : -0.107169 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40647 - DELTA_TIME : 0.000863886 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000858874704387 -******** CURRENT TIME = 4.40733259015 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.43205 - Final Residual ratio : 0.00234601 - Residual ratio : 0.000683558 - Slope : -0.118266 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40733 - DELTA_TIME : 0.000858875 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000853956716063 -******** CURRENT TIME = 4.40818654687 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.23985 - Final Residual ratio : 0.00222131 - Residual ratio : 0.000685623 - Slope : -0.107921 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40819 - DELTA_TIME : 0.000853957 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000849123739764 -******** CURRENT TIME = 4.40903567061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.9986 - Final Residual ratio : 0.00277558 - Residual ratio : 0.000925627 - Slope : -0.0998607 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40904 - DELTA_TIME : 0.000849124 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000844380168934 -******** CURRENT TIME = 4.40988005077 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.81851 - Final Residual ratio : 0.00255636 - Residual ratio : 0.000906989 - Slope : -0.0908373 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.40988 - DELTA_TIME : 0.00084438 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000839724480621 -******** CURRENT TIME = 4.41071977525 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.56452 - Final Residual ratio : 0.00342553 - Residual ratio : 0.000961009 - Slope : -0.122796 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41072 - DELTA_TIME : 0.000839724 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000835158525443 -******** CURRENT TIME = 4.41155493378 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.3187 - Final Residual ratio : 0.0448036 - Residual ratio : 0.000856359 - Slope : -1.86693 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41155 - DELTA_TIME : 0.000835159 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000830682853485 -******** CURRENT TIME = 4.41238561663 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 60.3459 - Final Residual ratio : 0.0480448 - Residual ratio : 0.000796158 - Slope : -2.15349 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41239 - DELTA_TIME : 0.000830683 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.41239 - DELTA_TIME : 0.00851904 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 115 - - Mesh vertices: 110 - Mesh triangles: 115 - Mesh edges: 188 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.41239 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.780270e+05 Mflops = 365.49 -Solve time = 0.00 -Solve flops = 1.635000e+04 Mflops = 479.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0983344; expected ratio = 0.0001obtained abs = 0.00148051; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.32505; expected ratio = 0.001obtained abs = 117.798; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.789730e+05 Mflops = 379.12 -Solve time = 0.00 -Solve flops = 1.640600e+04 Mflops = 498.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0215596; expected ratio = 0.0001obtained abs = 0.000327437; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.259676; expected ratio = 0.001obtained abs = 90.4492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.784210e+05 Mflops = 379.68 -Solve time = 0.00 -Solve flops = 1.637400e+04 Mflops = 480.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00727825; expected ratio = 0.0001obtained abs = 0.000110484; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.256723; expected ratio = 0.001obtained abs = 87.6852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.782310e+05 Mflops = 379.28 -Solve time = 0.00 -Solve flops = 1.638200e+04 Mflops = 494.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0306439; expected ratio = 0.0001obtained abs = 0.000466426; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.32693; expected ratio = 0.001obtained abs = 98.9912; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.768530e+05 Mflops = 379.42 -Solve time = 0.00 -Solve flops = 1.638400e+04 Mflops = 497.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.025683; expected ratio = 0.0001obtained abs = 0.00039131; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.136991; expected ratio = 0.001obtained abs = 39.4946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.769430e+05 Mflops = 378.84 -Solve time = 0.00 -Solve flops = 1.639000e+04 Mflops = 494.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00236349; expected ratio = 0.0001obtained abs = 3.60016e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00387242; expected ratio = 0.001obtained abs = 1.11489; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.769430e+05 Mflops = 378.84 -Solve time = 0.00 -Solve flops = 1.639000e+04 Mflops = 498.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000227358; expected ratio = 0.0001obtained abs = 3.46332e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000479124; expected ratio = 0.001obtained abs = 0.13794; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.769430e+05 Mflops = 379.62 -Solve time = 0.00 -Solve flops = 1.639000e+04 Mflops = 498.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.10984e-05; expected ratio = 0.0001obtained abs = 4.73716e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.29495e-05; expected ratio = 0.001obtained abs = 0.00948605; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000826325452427 -******** CURRENT TIME = 4.41321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.1569 - Final Residual ratio : 0.0231049 - Residual ratio : 0.00088332 - Slope : -0.871126 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41321 - DELTA_TIME : 0.000826325 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.41421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 205.565 - Final Residual ratio : 0.146666 - Residual ratio : 0.000713479 - Slope : -7.33636 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.41521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 74.0424 - Final Residual ratio : 0.0595946 - Residual ratio : 0.000804871 - Slope : -2.64224 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.41621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.4198 - Final Residual ratio : 0.032916 - Residual ratio : 0.000856747 - Slope : -1.32368 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.41721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 56.9495 - Final Residual ratio : 0.048293 - Residual ratio : 0.000847996 - Slope : -2.10745 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.41821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.016 - Final Residual ratio : 0.0371482 - Residual ratio : 0.000905701 - Slope : -1.51773 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.41921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.9415 - Final Residual ratio : 0.0313994 - Residual ratio : 0.000983029 - Slope : -1.13965 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.41921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.42021194209 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.7568 - Final Residual ratio : 0.0157552 - Residual ratio : 0.000759037 - Slope : -0.740752 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.42121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.9401 - Final Residual ratio : 0.0153115 - Residual ratio : 0.00085348 - Slope : -0.618095 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.42221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.0847 - Final Residual ratio : 0.0160015 - Residual ratio : 0.000936598 - Slope : -0.533398 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.42221 - DELTA_TIME : 0.00982633 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 115 - - Mesh vertices: 110 - Mesh triangles: 115 - Mesh edges: 188 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.42221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.779610e+05 Mflops = 369.88 -Solve time = 0.00 -Solve flops = 1.644600e+04 Mflops = 485.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.104679; expected ratio = 0.0001obtained abs = 0.00166478; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.297127; expected ratio = 0.001obtained abs = 102.515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.765910e+05 Mflops = 372.57 -Solve time = 0.00 -Solve flops = 1.627200e+04 Mflops = 491.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0448126; expected ratio = 0.0001obtained abs = 0.000700696; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0484215; expected ratio = 0.001obtained abs = 17.3211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.773330e+05 Mflops = 374.89 -Solve time = 0.00 -Solve flops = 1.629800e+04 Mflops = 491.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0126759; expected ratio = 0.0001obtained abs = 0.000198317; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0229055; expected ratio = 0.001obtained abs = 8.31009; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.771230e+05 Mflops = 372.95 -Solve time = 0.00 -Solve flops = 1.628600e+04 Mflops = 491.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0056715; expected ratio = 0.0001obtained abs = 8.86293e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00867208; expected ratio = 0.001obtained abs = 3.15108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.768430e+05 Mflops = 372.36 -Solve time = 0.00 -Solve flops = 1.626600e+04 Mflops = 490.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00228925; expected ratio = 0.0001obtained abs = 3.57786e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00435172; expected ratio = 0.001obtained abs = 1.58222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 372.11 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 495.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00101544; expected ratio = 0.0001obtained abs = 1.58698e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00164371; expected ratio = 0.001obtained abs = 0.597756; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 372.29 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 492.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000512927; expected ratio = 0.0001obtained abs = 8.01643e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00182518; expected ratio = 0.001obtained abs = 0.663995; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 372.11 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 481.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000299329; expected ratio = 0.0001obtained abs = 4.67815e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00107991; expected ratio = 0.001obtained abs = 0.392843; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 372.29 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 377.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000263352; expected ratio = 0.0001obtained abs = 4.11586e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00196153; expected ratio = 0.001obtained abs = 0.713764; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 371.36 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 492.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000312293; expected ratio = 0.0001obtained abs = 4.88076e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00235723; expected ratio = 0.001obtained abs = 0.857505; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 365.35 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 495.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000394761; expected ratio = 0.0001obtained abs = 6.16956e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0032208; expected ratio = 0.001obtained abs = 1.17217; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 372.85 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 495.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000567353; expected ratio = 0.0001obtained abs = 8.86705e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0044685; expected ratio = 0.001obtained abs = 1.6253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 372.85 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 495.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000674182; expected ratio = 0.0001obtained abs = 1.05365e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00531354; expected ratio = 0.001obtained abs = 1.93394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 373.04 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 495.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00084471; expected ratio = 0.0001obtained abs = 1.32019e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0065534; expected ratio = 0.001obtained abs = 2.3832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 373.04 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 495.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00092749; expected ratio = 0.0001obtained abs = 1.44953e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00707645; expected ratio = 0.001obtained abs = 2.57558; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 372.85 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 495.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00102206; expected ratio = 0.0001obtained abs = 1.59737e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00775859; expected ratio = 0.001obtained abs = 2.82116; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 371.36 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 481.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00106458; expected ratio = 0.0001obtained abs = 1.66378e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00795445; expected ratio = 0.001obtained abs = 2.89506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 373.60 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 481.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00109893; expected ratio = 0.0001obtained abs = 1.7175e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00821075; expected ratio = 0.001obtained abs = 2.98542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 372.11 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 481.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0011149; expected ratio = 0.0001obtained abs = 1.74242e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00825298; expected ratio = 0.001obtained abs = 3.00366; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775230e+05 Mflops = 372.11 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 495.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00112333; expected ratio = 0.0001obtained abs = 1.75564e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00832761; expected ratio = 0.001obtained abs = 3.02785; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.42321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.0438 - Final Residual ratio : 0.0131716 - Residual ratio : 0.000729977 - Slope : -0.546383 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.42421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.0825 - Final Residual ratio : 0.0168851 - Residual ratio : 0.000933782 - Slope : -0.602186 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.42521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 79.9685 - Final Residual ratio : 0.0784301 - Residual ratio : 0.000980762 - Slope : -2.75483 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.42621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.2081 - Final Residual ratio : 0.0628546 - Residual ratio : 0.000729103 - Slope : -2.87151 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.42721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.8122 - Final Residual ratio : 0.0104256 - Residual ratio : 0.000554197 - Slope : -0.626725 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.42821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.5996 - Final Residual ratio : 0.0190729 - Residual ratio : 0.000775332 - Slope : -0.847606 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.42921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.6994 - Final Residual ratio : 0.0129503 - Residual ratio : 0.000524314 - Slope : -0.851258 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.42921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 4.43021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.7143 - Final Residual ratio : 0.0188485 - Residual ratio : 0.000868022 - Slope : -0.748118 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.43121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.151 - Final Residual ratio : 0.019482 - Residual ratio : 0.000966798 - Slope : -0.671051 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.43221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.9879 - Final Residual ratio : 0.0631982 - Residual ratio : 0.000902988 - Slope : -2.18515 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.43221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 115 - - Mesh vertices: 110 - Mesh triangles: 115 - Mesh edges: 188 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.43221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.750770e+05 Mflops = 365.52 -Solve time = 0.00 -Solve flops = 1.617800e+04 Mflops = 491.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0710798; expected ratio = 0.0001obtained abs = 0.00113304; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.31202; expected ratio = 0.001obtained abs = 98.3911; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.747550e+05 Mflops = 367.22 -Solve time = 0.00 -Solve flops = 1.627000e+04 Mflops = 494.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0331645; expected ratio = 0.0001obtained abs = 0.000535589; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.138535; expected ratio = 0.001obtained abs = 41.8991; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.762870e+05 Mflops = 368.78 -Solve time = 0.00 -Solve flops = 1.635200e+04 Mflops = 493.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0119593; expected ratio = 0.0001obtained abs = 0.000193054; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0362348; expected ratio = 0.001obtained abs = 10.7802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.775290e+05 Mflops = 371.38 -Solve time = 0.00 -Solve flops = 1.642600e+04 Mflops = 499.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00560942; expected ratio = 0.0001obtained abs = 9.05907e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0225048; expected ratio = 0.001obtained abs = 6.6156; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.767370e+05 Mflops = 371.39 -Solve time = 0.00 -Solve flops = 1.637800e+04 Mflops = 508.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00211645; expected ratio = 0.0001obtained abs = 3.4181e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00510863; expected ratio = 0.001obtained abs = 1.4977; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.767370e+05 Mflops = 371.39 -Solve time = 0.00 -Solve flops = 1.637800e+04 Mflops = 508.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000179375; expected ratio = 0.0001obtained abs = 2.89694e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000915725; expected ratio = 0.001obtained abs = 0.268344; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.767370e+05 Mflops = 371.39 -Solve time = 0.00 -Solve flops = 1.637800e+04 Mflops = 508.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.73179e-05; expected ratio = 0.0001obtained abs = 2.79688e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.46159e-05; expected ratio = 0.001obtained abs = 0.0247947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.43321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 98.6335 - Final Residual ratio : 0.0776279 - Residual ratio : 0.000787035 - Slope : -3.65022 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.43421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 166.511 - Final Residual ratio : 0.133862 - Residual ratio : 0.000803926 - Slope : -5.36699 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.43521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 164.37 - Final Residual ratio : 0.136061 - Residual ratio : 0.000827772 - Slope : -5.47448 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.43621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.2388 - Final Residual ratio : 0.04646 - Residual ratio : 0.000963125 - Slope : -1.72115 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.43721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.1738 - Final Residual ratio : 0.0228128 - Residual ratio : 0.000943698 - Slope : -0.862535 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.43821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.0149 - Final Residual ratio : 0.029175 - Residual ratio : 0.000883693 - Slope : -1.06406 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.43921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.3793 - Final Residual ratio : 0.0379165 - Residual ratio : 0.00098794 - Slope : -1.27805 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.43921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.44021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.3748 - Final Residual ratio : 0.0288176 - Residual ratio : 0.000771044 - Slope : -1.24487 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.44121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.8797 - Final Residual ratio : 0.0318632 - Residual ratio : 0.000969083 - Slope : -1.13269 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.44221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.9983 - Final Residual ratio : 0.0241243 - Residual ratio : 0.000861635 - Slope : -1.07593 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.44221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 115 - - Mesh vertices: 110 - Mesh triangles: 115 - Mesh edges: 188 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.44221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.767370e+05 Mflops = 360.72 -Solve time = 0.00 -Solve flops = 1.637800e+04 Mflops = 480.38 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0858186; expected ratio = 0.0001obtained abs = 0.00145524; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.189496; expected ratio = 0.001obtained abs = 62.7211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.778530e+05 Mflops = 372.80 -Solve time = 0.00 -Solve flops = 1.636000e+04 Mflops = 493.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.025703; expected ratio = 0.0001obtained abs = 0.000431699; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0597208; expected ratio = 0.001obtained abs = 20.5349; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438213 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.774610e+05 Mflops = 374.41 -Solve time = 0.00 -Solve flops = 1.631400e+04 Mflops = 510.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0104102; expected ratio = 0.0001obtained abs = 0.000174404; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0386968; expected ratio = 0.001obtained abs = 13.5865; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.774130e+05 Mflops = 372.62 -Solve time = 0.00 -Solve flops = 1.631200e+04 Mflops = 510.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00683758; expected ratio = 0.0001obtained abs = 0.000114289; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.028073; expected ratio = 0.001obtained abs = 9.97616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.770170e+05 Mflops = 373.47 -Solve time = 0.00 -Solve flops = 1.628600e+04 Mflops = 491.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00493687; expected ratio = 0.0001obtained abs = 8.23975e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0214596; expected ratio = 0.001obtained abs = 7.68976; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.784150e+05 Mflops = 371.75 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 497.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00363173; expected ratio = 0.0001obtained abs = 6.05478e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0167093; expected ratio = 0.001obtained abs = 6.02702; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.776290e+05 Mflops = 372.33 -Solve time = 0.00 -Solve flops = 1.631600e+04 Mflops = 495.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00297349; expected ratio = 0.0001obtained abs = 4.95319e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0134428; expected ratio = 0.001obtained abs = 4.874; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.776290e+05 Mflops = 372.33 -Solve time = 0.00 -Solve flops = 1.631600e+04 Mflops = 495.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00229346; expected ratio = 0.0001obtained abs = 3.81762e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0107404; expected ratio = 0.001obtained abs = 3.91136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.781050e+05 Mflops = 373.51 -Solve time = 0.00 -Solve flops = 1.634400e+04 Mflops = 493.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00195918; expected ratio = 0.0001obtained abs = 3.25929e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00899369; expected ratio = 0.001obtained abs = 3.28645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.779230e+05 Mflops = 372.95 -Solve time = 0.00 -Solve flops = 1.633200e+04 Mflops = 511.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00150459; expected ratio = 0.0001obtained abs = 2.50182e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00709646; expected ratio = 0.001obtained abs = 2.60081; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.783990e+05 Mflops = 373.20 -Solve time = 0.00 -Solve flops = 1.636000e+04 Mflops = 493.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00128696; expected ratio = 0.0001obtained abs = 2.13914e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00606377; expected ratio = 0.001obtained abs = 2.22739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.779230e+05 Mflops = 366.71 -Solve time = 0.00 -Solve flops = 1.633200e+04 Mflops = 496.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000982814; expected ratio = 0.0001obtained abs = 1.63309e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00468395; expected ratio = 0.001obtained abs = 1.72396; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.783990e+05 Mflops = 372.45 -Solve time = 0.00 -Solve flops = 1.636000e+04 Mflops = 493.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000855126; expected ratio = 0.0001obtained abs = 1.42057e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00408867; expected ratio = 0.001obtained abs = 1.50712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.759790e+05 Mflops = 371.10 -Solve time = 0.00 -Solve flops = 1.627200e+04 Mflops = 494.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000648002; expected ratio = 0.0001obtained abs = 1.07627e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00308544; expected ratio = 0.001obtained abs = 1.13883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.783990e+05 Mflops = 372.45 -Solve time = 0.00 -Solve flops = 1.636000e+04 Mflops = 512.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000577946; expected ratio = 0.0001obtained abs = 9.59763e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00276796; expected ratio = 0.001obtained abs = 1.02265; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.779230e+05 Mflops = 372.95 -Solve time = 0.00 -Solve flops = 1.633200e+04 Mflops = 496.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000434324; expected ratio = 0.0001obtained abs = 7.21162e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00203724; expected ratio = 0.001obtained abs = 0.753348; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.783990e+05 Mflops = 372.45 -Solve time = 0.00 -Solve flops = 1.636000e+04 Mflops = 512.08 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000400107; expected ratio = 0.0001obtained abs = 6.64281e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00189332; expected ratio = 0.001obtained abs = 0.700574; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.779230e+05 Mflops = 372.20 -Solve time = 0.00 -Solve flops = 1.633200e+04 Mflops = 496.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000299299; expected ratio = 0.0001obtained abs = 4.9687e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00135962; expected ratio = 0.001obtained abs = 0.503393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.783990e+05 Mflops = 372.45 -Solve time = 0.00 -Solve flops = 1.636000e+04 Mflops = 497.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000286122; expected ratio = 0.0001obtained abs = 4.74963e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00131928; expected ratio = 0.001obtained abs = 0.488654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.779230e+05 Mflops = 372.95 -Solve time = 0.00 -Solve flops = 1.633200e+04 Mflops = 492.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000215188; expected ratio = 0.0001obtained abs = 3.57192e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000929651; expected ratio = 0.001obtained abs = 0.344476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.44321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.6188 - Final Residual ratio : 0.032528 - Residual ratio : 0.000821024 - Slope : -1.31954 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.44421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.832 - Final Residual ratio : 0.0557621 - Residual ratio : 0.000834363 - Slope : -2.30263 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.44521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 61.4214 - Final Residual ratio : 0.0534409 - Residual ratio : 0.00087007 - Slope : -2.11614 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.44621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.0616 - Final Residual ratio : 0.0344863 - Residual ratio : 0.000688878 - Slope : -1.72507 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.44721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.8789 - Final Residual ratio : 0.061343 - Residual ratio : 0.000841712 - Slope : -2.69695 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.44821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.5546 - Final Residual ratio : 0.0206837 - Residual ratio : 0.000724356 - Slope : -0.983928 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.44921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 177.574 - Final Residual ratio : 0.15733 - Residual ratio : 0.000885996 - Slope : -12.6726 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.44921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.45021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.4698 - Final Residual ratio : 0.0611044 - Residual ratio : 0.00084317 - Slope : -2.49685 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.45121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 150.813 - Final Residual ratio : 0.11236 - Residual ratio : 0.00074503 - Slope : -5.5815 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.45221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.3186 - Final Residual ratio : 0.020525 - Residual ratio : 0.000844002 - Slope : -0.837865 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.45221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 115 - - Mesh vertices: 110 - Mesh triangles: 115 - Mesh edges: 188 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.45221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.758010e+05 Mflops = 368.50 -Solve time = 0.00 -Solve flops = 1.621800e+04 Mflops = 492.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0594448; expected ratio = 0.0001obtained abs = 0.00100069; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.20986; expected ratio = 0.001obtained abs = 69.4511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.741390e+05 Mflops = 373.03 -Solve time = 0.00 -Solve flops = 1.622600e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0329349; expected ratio = 0.0001obtained abs = 0.000561758; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.112819; expected ratio = 0.001obtained abs = 36.326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.736630e+05 Mflops = 372.77 -Solve time = 0.00 -Solve flops = 1.619800e+04 Mflops = 488.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00675498; expected ratio = 0.0001obtained abs = 0.000115153; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170481; expected ratio = 0.001obtained abs = 5.48046; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.741390e+05 Mflops = 373.03 -Solve time = 0.00 -Solve flops = 1.622600e+04 Mflops = 489.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00216427; expected ratio = 0.0001obtained abs = 3.69073e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0128409; expected ratio = 0.001obtained abs = 4.10597; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.741390e+05 Mflops = 362.84 -Solve time = 0.00 -Solve flops = 1.622600e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0011162; expected ratio = 0.0001obtained abs = 1.90394e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00393735; expected ratio = 0.001obtained abs = 1.2567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.741390e+05 Mflops = 372.84 -Solve time = 0.00 -Solve flops = 1.622600e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000489642; expected ratio = 0.0001obtained abs = 8.35266e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00288806; expected ratio = 0.001obtained abs = 0.920682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.741390e+05 Mflops = 373.60 -Solve time = 0.00 -Solve flops = 1.622600e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000319676; expected ratio = 0.0001obtained abs = 5.45363e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00156153; expected ratio = 0.001obtained abs = 0.497455; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.741390e+05 Mflops = 372.84 -Solve time = 0.00 -Solve flops = 1.622600e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000185476; expected ratio = 0.0001obtained abs = 3.16432e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00104931; expected ratio = 0.001obtained abs = 0.334127; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.741390e+05 Mflops = 365.93 -Solve time = 0.00 -Solve flops = 1.622600e+04 Mflops = 489.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000124362; expected ratio = 0.0001obtained abs = 2.12172e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000660241; expected ratio = 0.001obtained abs = 0.210176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,115) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.741390e+05 Mflops = 365.01 -Solve time = 0.00 -Solve flops = 1.622600e+04 Mflops = 493.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.9443e-05; expected ratio = 0.0001obtained abs = 1.35539e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00044083; expected ratio = 0.001obtained abs = 0.140303; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.45321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.2145 - Final Residual ratio : 0.0117957 - Residual ratio : 0.000775292 - Slope : -0.475084 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.45421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.99 - Final Residual ratio : 0.010403 - Residual ratio : 0.000743603 - Slope : -0.411165 - Tolerance : 0.001 - Number of iterations : 34 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.45521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.2465 - Final Residual ratio : 0.00982109 - Residual ratio : 0.000801953 - Slope : -0.382395 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.45621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.6648 - Final Residual ratio : 0.00798965 - Residual ratio : 0.000749158 - Slope : -0.333026 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.45721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.50089 - Final Residual ratio : 0.00892155 - Residual ratio : 0.000939023 - Slope : -0.316399 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.45821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.43965 - Final Residual ratio : 0.00766549 - Residual ratio : 0.000908272 - Slope : -0.281066 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.45921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.65714 - Final Residual ratio : 0.00672929 - Residual ratio : 0.000878825 - Slope : -0.239075 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.45921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.46021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.13448 - Final Residual ratio : 0.00516617 - Residual ratio : 0.000724113 - Slope : -0.237644 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.46121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.82253 - Final Residual ratio : 0.00489848 - Residual ratio : 0.000717986 - Slope : -0.206595 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.46221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.58547 - Final Residual ratio : 0.00616175 - Residual ratio : 0.000935658 - Slope : -0.212236 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.46221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 10 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 115 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 114 - - Mesh vertices: 110 - Mesh triangles: 114 - Mesh edges: 186 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.46221 -matrix_partition : [5](0,45,90,135,183) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 183 -RHS size in solver: 183 -Factor time = 0.00 -Factor flops = 1.651900e+05 Mflops = 365.43 -Solve time = 0.00 -Solve flops = 1.582600e+04 Mflops = 481.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0640566; expected ratio = 0.0001obtained abs = 0.00113523; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.103703; expected ratio = 0.001obtained abs = 33.4319; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 183 -RHS size in solver: 183 -Factor time = 0.00 -Factor flops = 1.624730e+05 Mflops = 361.90 -Solve time = 0.00 -Solve flops = 1.567600e+04 Mflops = 476.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0158975; expected ratio = 0.0001obtained abs = 0.000279609; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0302622; expected ratio = 0.001obtained abs = 9.8301; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 183 -RHS size in solver: 183 -Factor time = 0.00 -Factor flops = 1.628430e+05 Mflops = 352.61 -Solve time = 0.00 -Solve flops = 1.569800e+04 Mflops = 473.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00315432; expected ratio = 0.0001obtained abs = 5.55203e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00545708; expected ratio = 0.001obtained abs = 1.77022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000427008 -"finished parallel building" : finished parallel building -matrix size in solver: 183 -RHS size in solver: 183 -Factor time = 0.00 -Factor flops = 1.627120e+05 Mflops = 360.71 -Solve time = 0.00 -Solve flops = 1.568000e+04 Mflops = 476.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00104264; expected ratio = 0.0001obtained abs = 1.83487e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0031502; expected ratio = 0.001obtained abs = 1.02218; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 183 -RHS size in solver: 183 -Factor time = 0.00 -Factor flops = 1.627120e+05 Mflops = 360.71 -Solve time = 0.00 -Solve flops = 1.568000e+04 Mflops = 476.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000380047; expected ratio = 0.0001obtained abs = 6.68807e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000719232; expected ratio = 0.001obtained abs = 0.233454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000424862 -"finished parallel building" : finished parallel building -matrix size in solver: 183 -RHS size in solver: 183 -Factor time = 0.00 -Factor flops = 1.627120e+05 Mflops = 361.47 -Solve time = 0.00 -Solve flops = 1.568000e+04 Mflops = 476.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000155619; expected ratio = 0.0001obtained abs = 2.73853e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000744848; expected ratio = 0.001obtained abs = 0.241842; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,28,56,84,114) -time: 0.000425816 -"finished parallel building" : finished parallel building -matrix size in solver: 183 -RHS size in solver: 183 -Factor time = 0.00 -Factor flops = 1.627120e+05 Mflops = 360.71 -Solve time = 0.00 -Solve flops = 1.568000e+04 Mflops = 476.57 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.99754e-05; expected ratio = 0.0001obtained abs = 1.40736e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000148967; expected ratio = 0.001obtained abs = 0.0483694; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.46321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.44139 - Final Residual ratio : 0.00505243 - Residual ratio : 0.000784369 - Slope : -0.201136 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.46421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.7045 - Final Residual ratio : 0.0663799 - Residual ratio : 0.000995134 - Slope : -2.56301 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.46521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 130.551 - Final Residual ratio : 0.117747 - Residual ratio : 0.000901926 - Slope : -4.65832 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.46621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 182.58 - Final Residual ratio : 0.121955 - Residual ratio : 0.00066795 - Slope : -6.08195 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.46721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 45.0701 - Final Residual ratio : 0.0246109 - Residual ratio : 0.000546057 - Slope : -1.73252 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.46821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.9407 - Final Residual ratio : 0.0271184 - Residual ratio : 0.000876462 - Slope : -0.936776 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.46921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.9049 - Final Residual ratio : 0.0320354 - Residual ratio : 0.000845151 - Slope : -1.18353 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.46921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.47021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.0181 - Final Residual ratio : 0.0264175 - Residual ratio : 0.000776571 - Slope : -1.06224 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.47121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.944 - Final Residual ratio : 0.0206777 - Residual ratio : 0.000797013 - Slope : -0.740666 - Tolerance : 0.001 - Number of iterations : 35 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.47221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.2753 - Final Residual ratio : 0.0144739 - Residual ratio : 0.000713867 - Slope : -0.698649 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.47221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 114 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 109 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - - Mesh vertices: 109 - Mesh triangles: 161 - Mesh edges: 269 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 161 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 109 - Input triangles: 114 - - Mesh vertices: 111 - Mesh triangles: 118 - Mesh edges: 192 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 2 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.47221 -matrix_partition : [5](0,46,92,138,187) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.552160e+05 Mflops = 341.92 -Solve time = 0.00 -Solve flops = 1.552000e+04 Mflops = 396.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.277208; expected ratio = 0.0001obtained abs = 0.00477878; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.668488; expected ratio = 0.001obtained abs = 402.693; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.543260e+05 Mflops = 342.12 -Solve time = 0.00 -Solve flops = 1.546200e+04 Mflops = 469.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.154812; expected ratio = 0.0001obtained abs = 0.00245649; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.269306; expected ratio = 0.001obtained abs = 202.8; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.542660e+05 Mflops = 343.62 -Solve time = 0.00 -Solve flops = 1.546600e+04 Mflops = 453.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0658824; expected ratio = 0.0001obtained abs = 0.0010152; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.115426; expected ratio = 0.001obtained abs = 93.8503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.544240e+05 Mflops = 343.06 -Solve time = 0.00 -Solve flops = 1.547600e+04 Mflops = 457.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0367245; expected ratio = 0.0001obtained abs = 0.000558772; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.051676; expected ratio = 0.001obtained abs = 43.7544; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.549500e+05 Mflops = 342.78 -Solve time = 0.00 -Solve flops = 1.550600e+04 Mflops = 454.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0238633; expected ratio = 0.0001obtained abs = 0.000360309; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0288662; expected ratio = 0.001obtained abs = 24.9416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000433922 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.549500e+05 Mflops = 344.41 -Solve time = 0.00 -Solve flops = 1.550600e+04 Mflops = 471.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0158478; expected ratio = 0.0001obtained abs = 0.000238142; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0178248; expected ratio = 0.001obtained abs = 15.595; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.536740e+05 Mflops = 340.67 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 455.88 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0110338; expected ratio = 0.0001obtained abs = 0.000165275; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119514; expected ratio = 0.001obtained abs = 10.5388; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.533340e+05 Mflops = 340.10 -Solve time = 0.00 -Solve flops = 1.541400e+04 Mflops = 468.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00777732; expected ratio = 0.0001obtained abs = 0.000116223; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00816089; expected ratio = 0.001obtained abs = 7.23422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.533340e+05 Mflops = 334.79 -Solve time = 0.00 -Solve flops = 1.541400e+04 Mflops = 465.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0056145; expected ratio = 0.0001obtained abs = 8.37549e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00578047; expected ratio = 0.001obtained abs = 5.14264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.535720e+05 Mflops = 340.45 -Solve time = 0.00 -Solve flops = 1.542800e+04 Mflops = 468.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0041; expected ratio = 0.0001obtained abs = 6.10848e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00412452; expected ratio = 0.001obtained abs = 3.6787; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.535720e+05 Mflops = 340.63 -Solve time = 0.00 -Solve flops = 1.542800e+04 Mflops = 465.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00300461; expected ratio = 0.0001obtained abs = 4.47235e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00297953; expected ratio = 0.001obtained abs = 2.66227; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.535720e+05 Mflops = 340.45 -Solve time = 0.00 -Solve flops = 1.542800e+04 Mflops = 465.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00220571; expected ratio = 0.0001obtained abs = 3.28097e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00215697; expected ratio = 0.001obtained abs = 1.92976; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.535720e+05 Mflops = 339.73 -Solve time = 0.00 -Solve flops = 1.542800e+04 Mflops = 468.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00161811; expected ratio = 0.0001obtained abs = 2.40573e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00156875; expected ratio = 0.001obtained abs = 1.40479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.535720e+05 Mflops = 340.45 -Solve time = 0.00 -Solve flops = 1.542800e+04 Mflops = 465.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00118656; expected ratio = 0.0001obtained abs = 1.76348e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114349; expected ratio = 0.001obtained abs = 1.02465; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.535720e+05 Mflops = 340.45 -Solve time = 0.00 -Solve flops = 1.542800e+04 Mflops = 452.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000870226; expected ratio = 0.0001obtained abs = 1.29299e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000833171; expected ratio = 0.001obtained abs = 0.746926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.540820e+05 Mflops = 340.86 -Solve time = 0.00 -Solve flops = 1.545800e+04 Mflops = 469.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000637284; expected ratio = 0.0001obtained abs = 9.46702e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000606032; expected ratio = 0.001obtained abs = 0.543481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000432968 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.540820e+05 Mflops = 341.04 -Solve time = 0.00 -Solve flops = 1.545800e+04 Mflops = 466.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000466033; expected ratio = 0.0001obtained abs = 6.92206e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000441025; expected ratio = 0.001obtained abs = 0.3956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.540820e+05 Mflops = 340.14 -Solve time = 0.00 -Solve flops = 1.545800e+04 Mflops = 453.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000340373; expected ratio = 0.0001obtained abs = 5.05509e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000320877; expected ratio = 0.001obtained abs = 0.287877; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.540820e+05 Mflops = 332.10 -Solve time = 0.00 -Solve flops = 1.545800e+04 Mflops = 453.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000248343; expected ratio = 0.0001obtained abs = 3.68802e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000233371; expected ratio = 0.001obtained abs = 0.209396; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,118) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 187 -RHS size in solver: 187 -Factor time = 0.00 -Factor flops = 1.540820e+05 Mflops = 340.86 -Solve time = 0.00 -Solve flops = 1.545800e+04 Mflops = 456.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000181026; expected ratio = 0.0001obtained abs = 2.68818e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000169681; expected ratio = 0.001obtained abs = 0.152263; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.47321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 45.6095 - Final Residual ratio : 0.0212373 - Residual ratio : 0.000465633 - Slope : -1.26634 - Tolerance : 0.001 - Number of iterations : 36 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.47421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 96.8456 - Final Residual ratio : 0.0876078 - Residual ratio : 0.000904614 - Slope : -4.39809 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.47521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 101.706 - Final Residual ratio : 0.0885291 - Residual ratio : 0.00087044 - Slope : -4.61898 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.47621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 75.5957 - Final Residual ratio : 0.0649383 - Residual ratio : 0.00085902 - Slope : -2.51769 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.47721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.8866 - Final Residual ratio : 0.0521724 - Residual ratio : 0.000986497 - Slope : -2.29715 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.47821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.0812 - Final Residual ratio : 0.0366612 - Residual ratio : 0.000938076 - Slope : -1.2595 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.47921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.2866 - Final Residual ratio : 0.0421982 - Residual ratio : 0.000997909 - Slope : -1.50873 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.47921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.48021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 78.6305 - Final Residual ratio : 0.0615993 - Residual ratio : 0.000783402 - Slope : -2.90996 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.48121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 113.45 - Final Residual ratio : 0.0674237 - Residual ratio : 0.000594305 - Slope : -3.65749 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.48221194209 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 80.4612 - Final Residual ratio : 0.0769766 - Residual ratio : 0.000956692 - Slope : -2.77187 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.48221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 111 - Number of Properties : 2 - Number of Elements : 118 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.48221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.581770e+05 Mflops = 349.92 -Solve time = 0.00 -Solve flops = 1.556400e+04 Mflops = 469.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.290772; expected ratio = 0.0001obtained abs = 0.00410152; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.84069; expected ratio = 0.001obtained abs = 1014.33; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.590810e+05 Mflops = 354.16 -Solve time = 0.00 -Solve flops = 1.561600e+04 Mflops = 474.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.154376; expected ratio = 0.0001obtained abs = 0.00226041; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.439279; expected ratio = 0.001obtained abs = 139.886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.590810e+05 Mflops = 354.35 -Solve time = 0.00 -Solve flops = 1.561600e+04 Mflops = 474.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0133613; expected ratio = 0.0001obtained abs = 0.00019483; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0163122; expected ratio = 0.001obtained abs = 5.13835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.590810e+05 Mflops = 354.35 -Solve time = 0.00 -Solve flops = 1.561600e+04 Mflops = 474.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00123788; expected ratio = 0.0001obtained abs = 1.80574e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000871253; expected ratio = 0.001obtained abs = 0.274535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.590810e+05 Mflops = 346.62 -Solve time = 0.00 -Solve flops = 1.561600e+04 Mflops = 458.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000118748; expected ratio = 0.0001obtained abs = 1.73214e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.56187e-05; expected ratio = 0.001obtained abs = 0.0175253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.590810e+05 Mflops = 351.18 -Solve time = 0.00 -Solve flops = 1.561600e+04 Mflops = 474.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.15886e-05; expected ratio = 0.0001obtained abs = 1.69041e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.06168e-06; expected ratio = 0.001obtained abs = 0.00127983; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.48321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.8628 - Final Residual ratio : 0.0353111 - Residual ratio : 0.00090861 - Slope : -1.33888 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.48421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.2356 - Final Residual ratio : 0.0202605 - Residual ratio : 0.000609602 - Slope : -1.03798 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.48521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.2585 - Final Residual ratio : 0.0301093 - Residual ratio : 0.000963235 - Slope : -1.04095 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.48621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.041 - Final Residual ratio : 0.0170363 - Residual ratio : 0.000607551 - Slope : -0.934131 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.48721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.5404 - Final Residual ratio : 0.0177685 - Residual ratio : 0.000754811 - Slope : -0.784087 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.48821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.4465 - Final Residual ratio : 0.0166435 - Residual ratio : 0.000902254 - Slope : -0.614329 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.48921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.0111 - Final Residual ratio : 0.0264878 - Residual ratio : 0.00080239 - Slope : -1.09949 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.48921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.49021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 84.315 - Final Residual ratio : 0.0663979 - Residual ratio : 0.000787498 - Slope : -2.80829 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.49121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 101.838 - Final Residual ratio : 0.0924878 - Residual ratio : 0.000908187 - Slope : -5.35502 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.49221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.3179 - Final Residual ratio : 0.0164689 - Residual ratio : 0.000810564 - Slope : -0.676713 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.49221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.49221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000426054 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616820e+05 Mflops = 348.30 -Solve time = 0.00 -Solve flops = 1.585000e+04 Mflops = 481.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0986337; expected ratio = 0.0001obtained abs = 0.00148739; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.06635; expected ratio = 0.001obtained abs = 513.757; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000423193 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.563150e+05 Mflops = 328.97 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 471.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.110475; expected ratio = 0.0001obtained abs = 0.00158518; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0838323; expected ratio = 0.001obtained abs = 42.8103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547970e+05 Mflops = 335.88 -Solve time = 0.00 -Solve flops = 1.543400e+04 Mflops = 465.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0377073; expected ratio = 0.0001obtained abs = 0.000531209; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0598237; expected ratio = 0.001obtained abs = 31.9272; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.547350e+05 Mflops = 334.19 -Solve time = 0.00 -Solve flops = 1.542800e+04 Mflops = 482.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0216121; expected ratio = 0.0001obtained abs = 0.000301738; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.031852; expected ratio = 0.001obtained abs = 17.3809; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.554190e+05 Mflops = 335.67 -Solve time = 0.00 -Solve flops = 1.547000e+04 Mflops = 484.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0130146; expected ratio = 0.0001obtained abs = 0.000180814; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0251784; expected ratio = 0.001obtained abs = 13.9477; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000413179 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.555450e+05 Mflops = 336.64 -Solve time = 0.00 -Solve flops = 1.547800e+04 Mflops = 484.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00883252; expected ratio = 0.0001obtained abs = 0.000122396; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0180248; expected ratio = 0.001obtained abs = 10.0117; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.555450e+05 Mflops = 335.94 -Solve time = 0.00 -Solve flops = 1.547800e+04 Mflops = 484.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00555094; expected ratio = 0.0001obtained abs = 7.68375e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0203529; expected ratio = 0.001obtained abs = 11.3758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.551550e+05 Mflops = 335.10 -Solve time = 0.00 -Solve flops = 1.545200e+04 Mflops = 469.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00532783; expected ratio = 0.0001obtained abs = 7.36814e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0198487; expected ratio = 0.001obtained abs = 11.07; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.551550e+05 Mflops = 335.10 -Solve time = 0.00 -Solve flops = 1.545200e+04 Mflops = 483.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00425877; expected ratio = 0.0001obtained abs = 5.88865e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0208972; expected ratio = 0.001obtained abs = 11.7109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000419855 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.555750e+05 Mflops = 335.32 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 467.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00455402; expected ratio = 0.0001obtained abs = 6.29352e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0210582; expected ratio = 0.001obtained abs = 11.763; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.555750e+05 Mflops = 336.01 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 467.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00411125; expected ratio = 0.0001obtained abs = 5.68207e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211952; expected ratio = 0.001obtained abs = 11.8915; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.556010e+05 Mflops = 335.37 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 470.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00431111; expected ratio = 0.0001obtained abs = 5.95588e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0212345; expected ratio = 0.001obtained abs = 11.8708; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.555750e+05 Mflops = 336.01 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 470.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00410038; expected ratio = 0.0001obtained abs = 5.66579e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211599; expected ratio = 0.001obtained abs = 11.8782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.556010e+05 Mflops = 335.37 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 467.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00420499; expected ratio = 0.0001obtained abs = 5.80838e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211809; expected ratio = 0.001obtained abs = 11.8454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.555750e+05 Mflops = 336.01 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 470.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.004102; expected ratio = 0.0001obtained abs = 5.66741e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0210897; expected ratio = 0.001obtained abs = 11.8419; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.556010e+05 Mflops = 335.37 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 470.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00415477; expected ratio = 0.0001obtained abs = 5.73858e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211377; expected ratio = 0.001obtained abs = 11.8234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.555750e+05 Mflops = 336.01 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 470.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00410504; expected ratio = 0.0001obtained abs = 5.67133e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0210544; expected ratio = 0.001obtained abs = 11.8235; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.556010e+05 Mflops = 335.37 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 470.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00413184; expected ratio = 0.0001obtained abs = 5.70671e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211237; expected ratio = 0.001obtained abs = 11.8166; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.556010e+05 Mflops = 336.06 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 470.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00410812; expected ratio = 0.0001obtained abs = 5.67544e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0210435; expected ratio = 0.001obtained abs = 11.8181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.556010e+05 Mflops = 335.37 -Solve time = 0.00 -Solve flops = 1.548200e+04 Mflops = 467.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00412194; expected ratio = 0.0001obtained abs = 5.69293e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0211223; expected ratio = 0.001obtained abs = 11.8163; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.49321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.2681 - Final Residual ratio : 0.0236801 - Residual ratio : 0.00086842 - Slope : -0.939461 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.49421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.3167 - Final Residual ratio : 0.0404647 - Residual ratio : 0.000979378 - Slope : -1.58755 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.49521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.7394 - Final Residual ratio : 0.0269877 - Residual ratio : 0.000679116 - Slope : -1.3694 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.49621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.3061 - Final Residual ratio : 0.0293111 - Residual ratio : 0.000907293 - Slope : -1.11299 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.49721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.3496 - Final Residual ratio : 0.0200285 - Residual ratio : 0.00082254 - Slope : -0.810986 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.49821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.1936 - Final Residual ratio : 0.016257 - Residual ratio : 0.000893556 - Slope : -0.60591 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.49921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.6534 - Final Residual ratio : 0.0101665 - Residual ratio : 0.000693794 - Slope : -0.488109 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.49921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.50021194209 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.1395 - Final Residual ratio : 0.00977168 - Residual ratio : 0.000743689 - Slope : -0.504989 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.50121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.5034 - Final Residual ratio : 0.0123073 - Residual ratio : 0.000984319 - Slope : -0.594813 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.50221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9068 - Final Residual ratio : 0.00578532 - Residual ratio : 0.000485884 - Slope : -0.3967 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.50221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.50221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000423908 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.554670e+05 Mflops = 328.01 -Solve time = 0.00 -Solve flops = 1.546600e+04 Mflops = 470.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.155764; expected ratio = 0.0001obtained abs = 0.00200194; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.23093; expected ratio = 0.001obtained abs = 372.365; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041604 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616260e+05 Mflops = 346.05 -Solve time = 0.00 -Solve flops = 1.584000e+04 Mflops = 467.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.100225; expected ratio = 0.0001obtained abs = 0.00136183; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.361818; expected ratio = 0.001obtained abs = 90.3662; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616260e+05 Mflops = 346.93 -Solve time = 0.00 -Solve flops = 1.584000e+04 Mflops = 477.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.016681; expected ratio = 0.0001obtained abs = 0.000225685; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0533418; expected ratio = 0.001obtained abs = 13.2417; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616260e+05 Mflops = 346.76 -Solve time = 0.00 -Solve flops = 1.584000e+04 Mflops = 467.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00309868; expected ratio = 0.0001obtained abs = 4.19557e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0157378; expected ratio = 0.001obtained abs = 3.89645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616260e+05 Mflops = 345.34 -Solve time = 0.00 -Solve flops = 1.584000e+04 Mflops = 481.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000755199; expected ratio = 0.0001obtained abs = 1.02253e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00363856; expected ratio = 0.001obtained abs = 0.900309; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000419855 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616260e+05 Mflops = 338.11 -Solve time = 0.00 -Solve flops = 1.584000e+04 Mflops = 481.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000168119; expected ratio = 0.0001obtained abs = 2.27635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000859272; expected ratio = 0.001obtained abs = 0.212585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616260e+05 Mflops = 346.05 -Solve time = 0.00 -Solve flops = 1.584000e+04 Mflops = 467.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.99326e-05; expected ratio = 0.0001obtained abs = 5.40695e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000199357; expected ratio = 0.001obtained abs = 0.0493196; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.50321194209 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.3954 - Final Residual ratio : 0.01127 - Residual ratio : 0.000988995 - Slope : -0.367231 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.50421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.6938 - Final Residual ratio : 0.00745951 - Residual ratio : 0.000697552 - Slope : -0.356213 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.50521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.53516 - Final Residual ratio : 0.00784396 - Residual ratio : 0.000822636 - Slope : -0.317577 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.50621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.47995 - Final Residual ratio : 0.00768965 - Residual ratio : 0.000906804 - Slope : -0.313787 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.50721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.82493 - Final Residual ratio : 0.00563666 - Residual ratio : 0.000720346 - Slope : -0.252235 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.50821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.21354 - Final Residual ratio : 0.00693026 - Residual ratio : 0.00096073 - Slope : -0.232471 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.50921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.49253 - Final Residual ratio : 0.00477208 - Residual ratio : 0.000735011 - Slope : -0.209282 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.50921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.51021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 229.386 - Final Residual ratio : 0.215549 - Residual ratio : 0.000939679 - Slope : -20.8337 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.51121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 87.9248 - Final Residual ratio : 0.0801389 - Residual ratio : 0.000911448 - Slope : -3.02913 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.51221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 192.861 - Final Residual ratio : 0.178793 - Residual ratio : 0.00092706 - Slope : -6.88149 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.51221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.51221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.614820e+05 Mflops = 348.05 -Solve time = 0.00 -Solve flops = 1.582800e+04 Mflops = 477.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0826847; expected ratio = 0.0001obtained abs = 0.00115968; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.579563; expected ratio = 0.001obtained abs = 223.608; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.584080e+05 Mflops = 342.13 -Solve time = 0.00 -Solve flops = 1.563400e+04 Mflops = 475.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0503787; expected ratio = 0.0001obtained abs = 0.000692326; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0719841; expected ratio = 0.001obtained abs = 28.8497; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.564130e+05 Mflops = 337.82 -Solve time = 0.00 -Solve flops = 1.552800e+04 Mflops = 471.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0132046; expected ratio = 0.0001obtained abs = 0.000180784; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0380778; expected ratio = 0.001obtained abs = 15.4763; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.02 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 467.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00745763; expected ratio = 0.0001obtained abs = 0.000101986; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0174539; expected ratio = 0.001obtained abs = 7.13157; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 330.39 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 470.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00343954; expected ratio = 0.0001obtained abs = 4.70095e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0108265; expected ratio = 0.001obtained abs = 4.43475; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.72 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 467.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00244089; expected ratio = 0.0001obtained abs = 3.33525e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00589608; expected ratio = 0.001obtained abs = 2.41628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 336.85 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 470.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00144286; expected ratio = 0.0001obtained abs = 1.97137e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00481231; expected ratio = 0.001obtained abs = 1.97377; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.72 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 481.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00130637; expected ratio = 0.0001obtained abs = 1.78474e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00325321; expected ratio = 0.001obtained abs = 1.33393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 338.42 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 467.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108227; expected ratio = 0.0001obtained abs = 1.47858e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0039407; expected ratio = 0.001obtained abs = 1.61685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000410795 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.55 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 470.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00121299; expected ratio = 0.0001obtained abs = 1.65709e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00368967; expected ratio = 0.001obtained abs = 1.51296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 336.85 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 470.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0012271; expected ratio = 0.0001obtained abs = 1.67642e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00441939; expected ratio = 0.001obtained abs = 1.8134; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 336.85 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 467.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00137681; expected ratio = 0.0001obtained abs = 1.88086e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00455957; expected ratio = 0.001obtained abs = 1.8695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 338.42 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 467.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00145701; expected ratio = 0.0001obtained abs = 1.99052e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00514119; expected ratio = 0.001obtained abs = 2.10965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.55 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 470.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00158251; expected ratio = 0.0001obtained abs = 2.16186e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00538621; expected ratio = 0.001obtained abs = 2.20824; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000422001 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.55 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 470.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00167498; expected ratio = 0.0001obtained abs = 2.28831e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00583622; expected ratio = 0.001obtained abs = 2.39494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 336.16 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 470.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00177055; expected ratio = 0.0001obtained abs = 2.41872e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00607982; expected ratio = 0.001obtained abs = 2.49246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.00041008 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.55 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 470.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00185098; expected ratio = 0.0001obtained abs = 2.52877e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00640387; expected ratio = 0.001obtained abs = 2.62799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.72 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 467.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00191734; expected ratio = 0.0001obtained abs = 2.61926e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0066006; expected ratio = 0.001obtained abs = 2.70587; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.72 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 467.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00197629; expected ratio = 0.0001obtained abs = 2.69997e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00681175; expected ratio = 0.001obtained abs = 2.79548; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.559650e+05 Mflops = 337.55 -Solve time = 0.00 -Solve flops = 1.549600e+04 Mflops = 485.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00201832; expected ratio = 0.0001obtained abs = 2.75719e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00695071; expected ratio = 0.001obtained abs = 2.84935; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.51321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.789 - Final Residual ratio : 0.0209059 - Residual ratio : 0.000538963 - Slope : -1.33683 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.51421194209 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.4853 - Final Residual ratio : 0.021719 - Residual ratio : 0.000887022 - Slope : -0.719516 - Tolerance : 0.001 - Number of iterations : 34 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.51521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.3633 - Final Residual ratio : 0.0291721 - Residual ratio : 0.000993485 - Slope : -0.946264 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.51621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.0097 - Final Residual ratio : 0.0207484 - Residual ratio : 0.00074076 - Slope : -0.965135 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.51721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.2094 - Final Residual ratio : 0.0241037 - Residual ratio : 0.000797887 - Slope : -1.16097 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.51821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.8404 - Final Residual ratio : 0.0195153 - Residual ratio : 0.00081858 - Slope : -0.882255 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.51921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 217.783 - Final Residual ratio : 0.199583 - Residual ratio : 0.000916431 - Slope : -7.01883 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.51921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.52021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 270.132 - Final Residual ratio : 0.219622 - Residual ratio : 0.000813018 - Slope : -8.70687 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.52121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 167.168 - Final Residual ratio : 0.133513 - Residual ratio : 0.000798677 - Slope : -5.3882 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.52221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.1434 - Final Residual ratio : 0.03855 - Residual ratio : 0.000936968 - Slope : -1.37016 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.52221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.52221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.556920e+05 Mflops = 338.53 -Solve time = 0.00 -Solve flops = 1.543800e+04 Mflops = 469.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0577051; expected ratio = 0.0001obtained abs = 0.000798917; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.538004; expected ratio = 0.001obtained abs = 161.449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.578140e+05 Mflops = 347.65 -Solve time = 0.00 -Solve flops = 1.556000e+04 Mflops = 472.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0288589; expected ratio = 0.0001obtained abs = 0.000401573; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0548994; expected ratio = 0.001obtained abs = 16.1852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.578140e+05 Mflops = 346.92 -Solve time = 0.00 -Solve flops = 1.556000e+04 Mflops = 472.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00372742; expected ratio = 0.0001obtained abs = 5.1869e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0146613; expected ratio = 0.001obtained abs = 4.30058; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000413179 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.578140e+05 Mflops = 341.55 -Solve time = 0.00 -Solve flops = 1.556000e+04 Mflops = 472.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000754466; expected ratio = 0.0001obtained abs = 1.05e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00348517; expected ratio = 0.001obtained abs = 1.02092; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.578140e+05 Mflops = 347.65 -Solve time = 0.00 -Solve flops = 1.556000e+04 Mflops = 472.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000137298; expected ratio = 0.0001obtained abs = 1.91082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000717982; expected ratio = 0.001obtained abs = 0.210262; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411034 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.578140e+05 Mflops = 346.74 -Solve time = 0.00 -Solve flops = 1.556000e+04 Mflops = 487.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.90184e-05; expected ratio = 0.0001obtained abs = 4.0386e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000146846; expected ratio = 0.001obtained abs = 0.0430017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.52321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 51.0333 - Final Residual ratio : 0.0421931 - Residual ratio : 0.000826776 - Slope : -1.64487 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.52421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 63.5881 - Final Residual ratio : 0.0534985 - Residual ratio : 0.000841329 - Slope : -2.11782 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.52521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 62.0602 - Final Residual ratio : 0.049875 - Residual ratio : 0.000803655 - Slope : -2.13829 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.52621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.8649 - Final Residual ratio : 0.0491053 - Residual ratio : 0.000928883 - Slope : -1.82123 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.52721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.8129 - Final Residual ratio : 0.0326683 - Residual ratio : 0.000763048 - Slope : -1.47518 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.52821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.038 - Final Residual ratio : 0.0310563 - Residual ratio : 0.000886359 - Slope : -1.25025 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.52921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.4123 - Final Residual ratio : 0.0247239 - Residual ratio : 0.000787077 - Slope : -1.08233 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.52921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 4.53021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.0455 - Final Residual ratio : 0.0167 - Residual ratio : 0.00057496 - Slope : -1.00099 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.53121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.7723 - Final Residual ratio : 0.0223861 - Residual ratio : 0.000868611 - Slope : -0.919641 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.53221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.9895 - Final Residual ratio : 0.0201325 - Residual ratio : 0.000915549 - Slope : -0.757564 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.53221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.53221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.577660e+05 Mflops = 342.86 -Solve time = 0.00 -Solve flops = 1.555400e+04 Mflops = 472.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0737552; expected ratio = 0.0001obtained abs = 0.00106769; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.283685; expected ratio = 0.001obtained abs = 96.9603; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.571980e+05 Mflops = 344.66 -Solve time = 0.00 -Solve flops = 1.552400e+04 Mflops = 471.83 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0151688; expected ratio = 0.0001obtained abs = 0.000218205; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0178106; expected ratio = 0.001obtained abs = 6.17; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.571500e+05 Mflops = 344.56 -Solve time = 0.00 -Solve flops = 1.552800e+04 Mflops = 471.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00318733; expected ratio = 0.0001obtained abs = 4.58439e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00340374; expected ratio = 0.001obtained abs = 1.18154; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.571500e+05 Mflops = 344.74 -Solve time = 0.00 -Solve flops = 1.552800e+04 Mflops = 482.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000761816; expected ratio = 0.0001obtained abs = 1.09562e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000460827; expected ratio = 0.001obtained abs = 0.159971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000410795 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.572520e+05 Mflops = 344.78 -Solve time = 0.00 -Solve flops = 1.552800e+04 Mflops = 486.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000103998; expected ratio = 0.0001obtained abs = 1.49568e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.01296e-05; expected ratio = 0.001obtained abs = 0.0312857; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000411987 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.572520e+05 Mflops = 344.78 -Solve time = 0.00 -Solve flops = 1.552800e+04 Mflops = 471.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.1734e-05; expected ratio = 0.0001obtained abs = 3.12575e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.95149e-05; expected ratio = 0.001obtained abs = 0.00677394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.53321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.0404 - Final Residual ratio : 0.0160561 - Residual ratio : 0.000890004 - Slope : -0.600813 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.53421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.1626 - Final Residual ratio : 0.00978189 - Residual ratio : 0.000605217 - Slope : -0.538428 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.53521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.4882 - Final Residual ratio : 0.0154794 - Residual ratio : 0.000999427 - Slope : -0.515759 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.53621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.6397 - Final Residual ratio : 0.0115798 - Residual ratio : 0.00079099 - Slope : -0.471873 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.53721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.5708 - Final Residual ratio : 0.059801 - Residual ratio : 0.000898306 - Slope : -2.29348 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.53821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.5749 - Final Residual ratio : 0.0404729 - Residual ratio : 0.000868985 - Slope : -1.60463 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.53921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2779 - Final Residual ratio : 0.0124454 - Residual ratio : 0.000764561 - Slope : -0.508295 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.53921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.54021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.6621 - Final Residual ratio : 0.0112177 - Residual ratio : 0.00082108 - Slope : -0.413662 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.54121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.9943 - Final Residual ratio : 0.0107735 - Residual ratio : 0.000769849 - Slope : -0.41128 - Tolerance : 0.001 - Number of iterations : 34 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.54221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.2026 - Final Residual ratio : 0.0135202 - Residual ratio : 0.000951955 - Slope : -0.443408 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.54221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.54221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.618390e+05 Mflops = 349.54 -Solve time = 0.00 -Solve flops = 1.582600e+04 Mflops = 464.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0590975; expected ratio = 0.0001obtained abs = 0.000879462; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.192858; expected ratio = 0.001obtained abs = 59.2625; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.635330e+05 Mflops = 345.72 -Solve time = 0.00 -Solve flops = 1.592000e+04 Mflops = 483.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0141028; expected ratio = 0.0001obtained abs = 0.000210051; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0260156; expected ratio = 0.001obtained abs = 7.89122; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000415087 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.635330e+05 Mflops = 354.66 -Solve time = 0.00 -Solve flops = 1.592000e+04 Mflops = 483.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129456; expected ratio = 0.0001obtained abs = 1.92818e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00203612; expected ratio = 0.001obtained abs = 0.6172; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.635330e+05 Mflops = 355.58 -Solve time = 0.00 -Solve flops = 1.592000e+04 Mflops = 466.95 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000150147; expected ratio = 0.0001obtained abs = 2.23639e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000418647; expected ratio = 0.001obtained abs = 0.126879; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000421047 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.635330e+05 Mflops = 354.66 -Solve time = 0.00 -Solve flops = 1.592000e+04 Mflops = 483.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.70349e-05; expected ratio = 0.0001obtained abs = 2.5373e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.42417e-05; expected ratio = 0.001obtained abs = 0.0224996; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.54321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.9539 - Final Residual ratio : 0.020875 - Residual ratio : 0.000909432 - Slope : -0.819035 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.54421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.2026 - Final Residual ratio : 0.0316273 - Residual ratio : 0.000786699 - Slope : -1.33903 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.54521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 93.768 - Final Residual ratio : 0.0720615 - Residual ratio : 0.000768509 - Slope : -3.1232 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.54621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 81.2273 - Final Residual ratio : 0.0690539 - Residual ratio : 0.000850132 - Slope : -2.70527 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.54721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.3504 - Final Residual ratio : 0.0157298 - Residual ratio : 0.000736744 - Slope : -0.711156 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.54821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.9897 - Final Residual ratio : 0.0150517 - Residual ratio : 0.000684487 - Slope : -0.757747 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.54921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.5665 - Final Residual ratio : 0.0182802 - Residual ratio : 0.000688093 - Slope : -0.856394 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.54921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.55021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.124 - Final Residual ratio : 0.0191715 - Residual ratio : 0.000763078 - Slope : -0.809832 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.55121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9608 - Final Residual ratio : 0.014399 - Residual ratio : 0.000721364 - Slope : -0.643434 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.55221194209 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.594 - Final Residual ratio : 0.0128497 - Residual ratio : 0.000945253 - Slope : -0.452703 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.55221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.55221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.0004251 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.631830e+05 Mflops = 356.29 -Solve time = 0.00 -Solve flops = 1.588400e+04 Mflops = 482.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0675094; expected ratio = 0.0001obtained abs = 0.00104705; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122331; expected ratio = 0.001obtained abs = 40.3884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.622610e+05 Mflops = 355.02 -Solve time = 0.00 -Solve flops = 1.582800e+04 Mflops = 481.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0131986; expected ratio = 0.0001obtained abs = 0.000203442; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0120527; expected ratio = 0.001obtained abs = 4.01799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.629070e+05 Mflops = 356.43 -Solve time = 0.00 -Solve flops = 1.586600e+04 Mflops = 482.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00214397; expected ratio = 0.0001obtained abs = 3.30481e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00182912; expected ratio = 0.001obtained abs = 0.610368; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000416994 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.619490e+05 Mflops = 353.60 -Solve time = 0.00 -Solve flops = 1.580800e+04 Mflops = 494.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000401102; expected ratio = 0.0001obtained abs = 6.18233e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00024733; expected ratio = 0.001obtained abs = 0.0825283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.619490e+05 Mflops = 344.63 -Solve time = 0.00 -Solve flops = 1.580800e+04 Mflops = 494.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.4299e-05; expected ratio = 0.0001obtained abs = 1.14521e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.04599e-05; expected ratio = 0.001obtained abs = 0.0201735; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.55321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 44.5519 - Final Residual ratio : 0.0316155 - Residual ratio : 0.000709634 - Slope : -1.39126 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.55421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 58.6295 - Final Residual ratio : 0.054658 - Residual ratio : 0.00093226 - Slope : -4.50576 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.55521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 53.8242 - Final Residual ratio : 0.0490339 - Residual ratio : 0.000911 - Slope : -2.33805 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.55621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 143.291 - Final Residual ratio : 0.124813 - Residual ratio : 0.00087104 - Slope : -4.93678 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.55721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 164.539 - Final Residual ratio : 0.156808 - Residual ratio : 0.000953012 - Slope : -5.66836 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.55821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.1738 - Final Residual ratio : 0.0234967 - Residual ratio : 0.000778711 - Slope : -0.97259 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.55921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.4456 - Final Residual ratio : 0.0218457 - Residual ratio : 0.000858528 - Slope : -0.847457 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.55921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.56021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.8739 - Final Residual ratio : 0.0133934 - Residual ratio : 0.000373347 - Slope : -1.23657 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.56121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 143.571 - Final Residual ratio : 0.131812 - Residual ratio : 0.000918098 - Slope : -5.73755 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.56221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 81.2792 - Final Residual ratio : 0.0635892 - Residual ratio : 0.000782355 - Slope : -2.70719 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.56221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.56221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.602250e+05 Mflops = 348.93 -Solve time = 0.00 -Solve flops = 1.570400e+04 Mflops = 477.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0537127; expected ratio = 0.0001obtained abs = 0.000854382; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0800691; expected ratio = 0.001obtained abs = 25.3526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414848 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.626490e+05 Mflops = 355.87 -Solve time = 0.00 -Solve flops = 1.585400e+04 Mflops = 496.24 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0155318; expected ratio = 0.0001obtained abs = 0.000247371; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0192305; expected ratio = 0.001obtained abs = 6.03495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.626450e+05 Mflops = 355.86 -Solve time = 0.00 -Solve flops = 1.585200e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0043547; expected ratio = 0.0001obtained abs = 6.93858e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00296964; expected ratio = 0.001obtained abs = 0.931981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.626450e+05 Mflops = 350.56 -Solve time = 0.00 -Solve flops = 1.585200e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000631581; expected ratio = 0.0001obtained abs = 1.00625e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000840016; expected ratio = 0.001obtained abs = 0.263725; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000413895 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.626450e+05 Mflops = 355.86 -Solve time = 0.00 -Solve flops = 1.585200e+04 Mflops = 492.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000172838; expected ratio = 0.0001obtained abs = 2.7537e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000144045; expected ratio = 0.001obtained abs = 0.0452212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.626450e+05 Mflops = 356.79 -Solve time = 0.00 -Solve flops = 1.585200e+04 Mflops = 492.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 3.10932e-05; expected ratio = 0.0001obtained abs = 4.95386e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.37829e-05; expected ratio = 0.001obtained abs = 0.0137448; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.56321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 125.175 - Final Residual ratio : 0.118737 - Residual ratio : 0.000948563 - Slope : -5.6844 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.56421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.9211 - Final Residual ratio : 0.0222002 - Residual ratio : 0.000717963 - Slope : -1.06548 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.56521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.373 - Final Residual ratio : 0.0216573 - Residual ratio : 0.000648946 - Slope : -1.07585 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.56621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.7414 - Final Residual ratio : 0.0301888 - Residual ratio : 0.000779239 - Slope : -1.24875 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.56721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.7809 - Final Residual ratio : 0.014256 - Residual ratio : 0.000686015 - Slope : -0.69222 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.56821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.1109 - Final Residual ratio : 0.0156085 - Residual ratio : 0.000968819 - Slope : -0.619049 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.56921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.9003 - Final Residual ratio : 0.0138236 - Residual ratio : 0.000994482 - Slope : -0.77147 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.56921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.57021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.5586 - Final Residual ratio : 0.00771587 - Residual ratio : 0.000614387 - Slope : -0.418364 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.57121194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5181 - Final Residual ratio : 0.00837834 - Residual ratio : 0.000727405 - Slope : -0.359679 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.57221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3305 - Final Residual ratio : 0.00939607 - Residual ratio : 0.000909547 - Slope : -0.332939 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.57221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 110 - Mesh triangles: 116 - Mesh edges: 189 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.57221 -matrix_partition : [5](0,46,92,138,184) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000422955 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.617070e+05 Mflops = 354.55 -Solve time = 0.00 -Solve flops = 1.577200e+04 Mflops = 479.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0571345; expected ratio = 0.0001obtained abs = 0.000944656; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0788653; expected ratio = 0.001obtained abs = 26.3475; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000417948 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.606330e+05 Mflops = 352.19 -Solve time = 0.00 -Solve flops = 1.570400e+04 Mflops = 491.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0145914; expected ratio = 0.0001obtained abs = 0.000239453; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0182618; expected ratio = 0.001obtained abs = 6.18718; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000420094 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.615290e+05 Mflops = 345.14 -Solve time = 0.00 -Solve flops = 1.576600e+04 Mflops = 493.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0035852; expected ratio = 0.0001obtained abs = 5.88204e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00364506; expected ratio = 0.001obtained abs = 1.23664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000414133 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616490e+05 Mflops = 352.94 -Solve time = 0.00 -Solve flops = 1.577400e+04 Mflops = 493.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000856522; expected ratio = 0.0001obtained abs = 1.40519e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000928968; expected ratio = 0.001obtained abs = 0.315233; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000413179 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616490e+05 Mflops = 354.61 -Solve time = 0.00 -Solve flops = 1.577400e+04 Mflops = 475.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00024299; expected ratio = 0.0001obtained abs = 3.98638e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000145731; expected ratio = 0.001obtained abs = 0.0494525; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,29,58,87,116) -time: 0.000412941 -"finished parallel building" : finished parallel building -matrix size in solver: 184 -RHS size in solver: 184 -Factor time = 0.00 -Factor flops = 1.616490e+05 Mflops = 353.68 -Solve time = 0.00 -Solve flops = 1.577400e+04 Mflops = 493.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.28884e-05; expected ratio = 0.0001obtained abs = 7.03607e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.66205e-05; expected ratio = 0.001obtained abs = 0.0158201; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.57321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.1352 - Final Residual ratio : 0.00687235 - Residual ratio : 0.000752294 - Slope : -0.294462 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.57421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 85.236 - Final Residual ratio : 0.0751711 - Residual ratio : 0.000881917 - Slope : -2.93658 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.57521194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.2638 - Final Residual ratio : 0.0246074 - Residual ratio : 0.000936931 - Slope : -0.971822 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57521 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.57621194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.1835 - Final Residual ratio : 0.00781227 - Residual ratio : 0.000698553 - Slope : -0.372523 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57621 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.57721194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.5795 - Final Residual ratio : 0.00573701 - Residual ratio : 0.000456059 - Slope : -0.392931 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57721 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.57821194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.0476 - Final Residual ratio : 0.00912459 - Residual ratio : 0.00064955 - Slope : -0.401098 - Tolerance : 0.001 - Number of iterations : 35 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57821 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.57921194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.5117 - Final Residual ratio : 0.00514054 - Residual ratio : 0.00041086 - Slope : -0.338014 - Tolerance : 0.001 - Number of iterations : 37 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.57921 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.58021194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.81002 - Final Residual ratio : 0.0047755 - Residual ratio : 0.000486799 - Slope : -0.306414 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.58021 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.58121194209 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.35538 - Final Residual ratio : 0.007851 - Residual ratio : 0.000939634 - Slope : -0.298126 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.58121 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.58221194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.8195 - Final Residual ratio : 0.0191385 - Residual ratio : 0.000392026 - Slope : -1.57421 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.58221 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.58221 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 110 - Number of Properties : 2 - Number of Elements : 116 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 110 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - - Mesh vertices: 110 - Mesh triangles: 163 - Mesh edges: 272 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 163 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 110 - Input triangles: 116 - - Mesh vertices: 112 - Mesh triangles: 120 - Mesh edges: 195 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 2 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.58221 -matrix_partition : [5](0,47,94,141,190) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 190 -RHS size in solver: 190 -Factor time = 0.00 -Factor flops = 1.742510e+05 Mflops = 370.06 -Solve time = 0.00 -Solve flops = 1.662800e+04 Mflops = 474.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0498172; expected ratio = 0.0001obtained abs = 0.000839805; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.08312; expected ratio = 0.001obtained abs = 26.8364; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000427961 -"finished parallel building" : finished parallel building -matrix size in solver: 190 -RHS size in solver: 190 -Factor time = 0.00 -Factor flops = 1.747550e+05 Mflops = 374.92 -Solve time = 0.00 -Solve flops = 1.665400e+04 Mflops = 491.92 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0129267; expected ratio = 0.0001obtained abs = 0.000218318; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122305; expected ratio = 0.001obtained abs = 3.95222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.00043416 -"finished parallel building" : finished parallel building -matrix size in solver: 190 -RHS size in solver: 190 -Factor time = 0.00 -Factor flops = 1.743150e+05 Mflops = 374.94 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 487.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0023944; expected ratio = 0.0001obtained abs = 4.04159e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00170918; expected ratio = 0.001obtained abs = 0.552948; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 190 -RHS size in solver: 190 -Factor time = 0.00 -Factor flops = 1.743150e+05 Mflops = 374.94 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 487.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000328936; expected ratio = 0.0001obtained abs = 5.55223e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000373254; expected ratio = 0.001obtained abs = 0.120754; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,120) -time: 0.000432014 -"finished parallel building" : finished parallel building -matrix size in solver: 190 -RHS size in solver: 190 -Factor time = 0.00 -Factor flops = 1.743150e+05 Mflops = 374.94 -Solve time = 0.00 -Solve flops = 1.662600e+04 Mflops = 487.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.63277e-05; expected ratio = 0.0001obtained abs = 1.11957e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.26372e-05; expected ratio = 0.001obtained abs = 0.0170285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.58321194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 182.239 - Final Residual ratio : 0.138696 - Residual ratio : 0.000761062 - Slope : -6.27934 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.58321 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.58421194209 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 220.217 - Final Residual ratio : 0.149624 - Residual ratio : 0.000679438 - Slope : -7.33557 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.58421 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000999689923465 -******** CURRENT TIME = 4.58521163201 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.5154 - Final Residual ratio : 0.0361199 - Residual ratio : 0.000687798 - Slope : -1.74931 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.58521 - DELTA_TIME : 0.00099969 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000994818324173 -******** CURRENT TIME = 4.58620645033 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.3512 - Final Residual ratio : 0.0312312 - Residual ratio : 0.00083615 - Slope : -1.16625 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.58621 - DELTA_TIME : 0.000994818 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000989483607642 -******** CURRENT TIME = 4.58719593394 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.1861 - Final Residual ratio : 0.0354637 - Residual ratio : 0.000821184 - Slope : -1.34846 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.5872 - DELTA_TIME : 0.000989484 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000982544429284 -******** CURRENT TIME = 4.58817847837 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.6494 - Final Residual ratio : 0.0321711 - Residual ratio : 0.000877808 - Slope : -1.22057 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.58818 - DELTA_TIME : 0.000982544 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000973216919752 -******** CURRENT TIME = 4.58915169529 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.8317 - Final Residual ratio : 0.0233453 - Residual ratio : 0.000870066 - Slope : -1.11701 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.58915 - DELTA_TIME : 0.000973217 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000961925002197 -******** CURRENT TIME = 4.59011362029 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.3163 - Final Residual ratio : 0.0210521 - Residual ratio : 0.000902893 - Slope : -0.727977 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59011 - DELTA_TIME : 0.000961925 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000949835390724 -******** CURRENT TIME = 4.59106345568 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.555 - Final Residual ratio : 0.0181793 - Residual ratio : 0.000771781 - Slope : -0.784562 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59106 - DELTA_TIME : 0.000949835 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000938094884045 -******** CURRENT TIME = 4.59200155057 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.7422 - Final Residual ratio : 0.0163392 - Residual ratio : 0.000787724 - Slope : -0.668578 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.592 - DELTA_TIME : 0.000938095 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.592 - DELTA_TIME : 0.00978961 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 112 - Number of Properties : 2 - Number of Elements : 120 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 112 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - - Mesh vertices: 112 - Mesh triangles: 167 - Mesh edges: 278 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 167 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - Input triangles: 120 - - Mesh vertices: 113 - Mesh triangles: 122 - Mesh edges: 198 - Mesh exterior boundary edges: 30 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 30 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.592 -matrix_partition : [5](0,48,96,144,193) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.753000e+05 Mflops = 366.71 -Solve time = 0.00 -Solve flops = 1.678800e+04 Mflops = 482.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0494043; expected ratio = 0.0001obtained abs = 0.000859876; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0587638; expected ratio = 0.001obtained abs = 18.6631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.731340e+05 Mflops = 364.55 -Solve time = 0.00 -Solve flops = 1.666200e+04 Mflops = 488.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.010755; expected ratio = 0.0001obtained abs = 0.000186293; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0128056; expected ratio = 0.001obtained abs = 4.08334; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.729180e+05 Mflops = 364.82 -Solve time = 0.00 -Solve flops = 1.664400e+04 Mflops = 505.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00226663; expected ratio = 0.0001obtained abs = 3.92915e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00218934; expected ratio = 0.001obtained abs = 0.698017; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.729180e+05 Mflops = 364.64 -Solve time = 0.00 -Solve flops = 1.664400e+04 Mflops = 491.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000379141; expected ratio = 0.0001obtained abs = 6.57195e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00037712; expected ratio = 0.001obtained abs = 0.120229; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.729180e+05 Mflops = 365.56 -Solve time = 0.00 -Solve flops = 1.664400e+04 Mflops = 488.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000102298; expected ratio = 0.0001obtained abs = 1.77323e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.48879e-05; expected ratio = 0.001obtained abs = 0.023875; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 193 -RHS size in solver: 193 -Factor time = 0.00 -Factor flops = 1.729180e+05 Mflops = 364.82 -Solve time = 0.00 -Solve flops = 1.664400e+04 Mflops = 488.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.23468e-05; expected ratio = 0.0001obtained abs = 7.34035e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.95672e-05; expected ratio = 0.001obtained abs = 0.0094263; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000927354598358 -******** CURRENT TIME = 4.59292890517 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.3427 - Final Residual ratio : 0.0110584 - Residual ratio : 0.000720757 - Slope : -0.494569 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59293 - DELTA_TIME : 0.000927355 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000917691561667 -******** CURRENT TIME = 4.59384659673 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8467 - Final Residual ratio : 0.0105115 - Residual ratio : 0.000818227 - Slope : -0.388974 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59385 - DELTA_TIME : 0.000917692 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000908808542582 -******** CURRENT TIME = 4.59475540527 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.7749 - Final Residual ratio : 0.0101852 - Residual ratio : 0.000739406 - Slope : -0.458823 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59476 - DELTA_TIME : 0.000908809 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000900295750111 -******** CURRENT TIME = 4.59565570102 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.0548 - Final Residual ratio : 0.0114925 - Residual ratio : 0.000880331 - Slope : -0.407603 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59566 - DELTA_TIME : 0.000900296 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000891842159335 -******** CURRENT TIME = 4.59654754318 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.3044 - Final Residual ratio : 0.0381477 - Residual ratio : 0.000773717 - Slope : -1.75951 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59655 - DELTA_TIME : 0.000891842 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000883337875661 -******** CURRENT TIME = 4.59743088106 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 124.33 - Final Residual ratio : 0.122484 - Residual ratio : 0.000985158 - Slope : -6.90039 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59743 - DELTA_TIME : 0.000883338 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000874565325419 -******** CURRENT TIME = 4.59830544638 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 148.511 - Final Residual ratio : 0.146447 - Residual ratio : 0.000986101 - Slope : -5.29873 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59831 - DELTA_TIME : 0.000874565 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000865502979994 -******** CURRENT TIME = 4.59917094936 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.4489 - Final Residual ratio : 0.0219734 - Residual ratio : 0.00077238 - Slope : -0.916999 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.59917 - DELTA_TIME : 0.000865503 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000857019627414 -******** CURRENT TIME = 4.60002796899 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.5239 - Final Residual ratio : 0.0214766 - Residual ratio : 0.000875741 - Slope : -0.816747 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60003 - DELTA_TIME : 0.00085702 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000849121486355 -******** CURRENT TIME = 4.60087709047 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.2134 - Final Residual ratio : 0.0245783 - Residual ratio : 0.000937623 - Slope : -0.935314 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60088 - DELTA_TIME : 0.000849121 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.60088 - DELTA_TIME : 0.00887554 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 30 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 112 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - - Mesh vertices: 112 - Mesh triangles: 167 - Mesh edges: 278 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 167 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 112 - Input triangles: 121 - - Mesh vertices: 113 - Mesh triangles: 123 - Mesh edges: 200 - Mesh exterior boundary edges: 31 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 31 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.60088 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.744990e+05 Mflops = 346.22 -Solve time = 0.00 -Solve flops = 1.675600e+04 Mflops = 478.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.040919; expected ratio = 0.0001obtained abs = 0.000726568; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.174157; expected ratio = 0.001obtained abs = 58.2694; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.745630e+05 Mflops = 359.97 -Solve time = 0.00 -Solve flops = 1.677200e+04 Mflops = 478.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0118696; expected ratio = 0.0001obtained abs = 0.000209832; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0386162; expected ratio = 0.001obtained abs = 13.2397; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.724350e+05 Mflops = 355.58 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 491.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00362017; expected ratio = 0.0001obtained abs = 6.38883e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0134538; expected ratio = 0.001obtained abs = 4.64718; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.724350e+05 Mflops = 355.58 -Solve time = 0.00 -Solve flops = 1.664200e+04 Mflops = 488.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00109188; expected ratio = 0.0001obtained abs = 1.92613e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00413756; expected ratio = 0.001obtained abs = 1.4327; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.725570e+05 Mflops = 355.83 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 491.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000531147; expected ratio = 0.0001obtained abs = 9.36801e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00151098; expected ratio = 0.001obtained abs = 0.523669; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 354.92 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 487.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000315792; expected ratio = 0.0001obtained abs = 5.56944e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000583233; expected ratio = 0.001obtained abs = 0.202182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 355.62 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 487.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000334999; expected ratio = 0.0001obtained abs = 5.90806e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000599926; expected ratio = 0.001obtained abs = 0.207998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 355.62 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 487.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00034651; expected ratio = 0.0001obtained abs = 6.11103e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000607716; expected ratio = 0.001obtained abs = 0.210687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 354.74 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 490.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000444595; expected ratio = 0.0001obtained abs = 7.84081e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000824201; expected ratio = 0.001obtained abs = 0.285765; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 355.62 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 501.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000558996; expected ratio = 0.0001obtained abs = 9.85841e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00104993; expected ratio = 0.001obtained abs = 0.363978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 354.92 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 490.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000680181; expected ratio = 0.0001obtained abs = 1.19956e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00128643; expected ratio = 0.001obtained abs = 0.446023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 355.62 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 487.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000834581; expected ratio = 0.0001obtained abs = 1.47187e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00161298; expected ratio = 0.001obtained abs = 0.559117; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.725570e+05 Mflops = 356.53 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 474.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000926289; expected ratio = 0.0001obtained abs = 1.63361e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00179488; expected ratio = 0.001obtained abs = 0.622288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 349.93 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 487.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00103053; expected ratio = 0.0001obtained abs = 1.81745e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00203898; expected ratio = 0.001obtained abs = 0.706724; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.725570e+05 Mflops = 356.53 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 491.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107807; expected ratio = 0.0001obtained abs = 1.90131e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00214478; expected ratio = 0.001obtained abs = 0.743582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 354.74 -Solve time = 0.00 -Solve flops = 1.661400e+04 Mflops = 490.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00112612; expected ratio = 0.0001obtained abs = 1.98604e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00227116; expected ratio = 0.001obtained abs = 0.787164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.725570e+05 Mflops = 355.83 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 488.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00114742; expected ratio = 0.0001obtained abs = 2.02362e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00232647; expected ratio = 0.001obtained abs = 0.806568; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.725570e+05 Mflops = 355.83 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 488.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116758; expected ratio = 0.0001obtained abs = 2.05916e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00238405; expected ratio = 0.001obtained abs = 0.82628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.725570e+05 Mflops = 355.83 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 488.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117699; expected ratio = 0.0001obtained abs = 2.07577e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00241041; expected ratio = 0.001obtained abs = 0.835675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.725570e+05 Mflops = 356.35 -Solve time = 0.00 -Solve flops = 1.664000e+04 Mflops = 491.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0011858; expected ratio = 0.0001obtained abs = 2.09129e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0024359; expected ratio = 0.001obtained abs = 0.844248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000841565377393 -******** CURRENT TIME = 4.60171865585 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.2673 - Final Residual ratio : 0.0202171 - Residual ratio : 0.000907925 - Slope : -0.74157 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60172 - DELTA_TIME : 0.000841565 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000834319593532 -******** CURRENT TIME = 4.60255297545 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.2574 - Final Residual ratio : 0.0159338 - Residual ratio : 0.000923304 - Slope : -0.538796 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60255 - DELTA_TIME : 0.00083432 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000827347207286 -******** CURRENT TIME = 4.60338032265 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.0973 - Final Residual ratio : 0.00975323 - Residual ratio : 0.000744673 - Slope : -0.408986 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60338 - DELTA_TIME : 0.000827347 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000820603382291 -******** CURRENT TIME = 4.60420092603 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4192 - Final Residual ratio : 0.00974953 - Residual ratio : 0.000935724 - Slope : -0.358948 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.6042 - DELTA_TIME : 0.000820603 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000814063125455 -******** CURRENT TIME = 4.60501498916 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.33017 - Final Residual ratio : 0.00709483 - Residual ratio : 0.000760419 - Slope : -0.300744 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60501 - DELTA_TIME : 0.000814063 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000807717632962 -******** CURRENT TIME = 4.60582270679 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.93336 - Final Residual ratio : 0.00732784 - Residual ratio : 0.000820278 - Slope : -0.270486 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60582 - DELTA_TIME : 0.000807718 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000801557577245 -******** CURRENT TIME = 4.60662426437 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.09244 - Final Residual ratio : 0.00667202 - Residual ratio : 0.000824476 - Slope : -0.245023 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60662 - DELTA_TIME : 0.000801558 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000795570551819 -******** CURRENT TIME = 4.60741983492 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.93299 - Final Residual ratio : 0.0063538 - Residual ratio : 0.000916459 - Slope : -0.22344 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60742 - DELTA_TIME : 0.000795571 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000789735620635 -******** CURRENT TIME = 4.60820957054 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.27514 - Final Residual ratio : 0.00453028 - Residual ratio : 0.00072194 - Slope : -0.202278 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60821 - DELTA_TIME : 0.000789736 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000784028083168 -******** CURRENT TIME = 4.60899359863 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.19279 - Final Residual ratio : 0.00450272 - Residual ratio : 0.00072709 - Slope : -0.187524 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60899 - DELTA_TIME : 0.000784028 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.60899 - DELTA_TIME : 0.00811651 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 31 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 122 - - Mesh vertices: 113 - Mesh triangles: 122 - Mesh edges: 199 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.60899 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.719680e+05 Mflops = 362.09 -Solve time = 0.00 -Solve flops = 1.648200e+04 Mflops = 483.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0302874; expected ratio = 0.0001obtained abs = 0.000540225; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.205347; expected ratio = 0.001obtained abs = 63.3915; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.733900e+05 Mflops = 367.48 -Solve time = 0.00 -Solve flops = 1.657000e+04 Mflops = 486.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0144219; expected ratio = 0.0001obtained abs = 0.00025865; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0529491; expected ratio = 0.001obtained abs = 16.0057; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.761920e+05 Mflops = 370.06 -Solve time = 0.00 -Solve flops = 1.674800e+04 Mflops = 494.69 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00446085; expected ratio = 0.0001obtained abs = 8.01134e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0124063; expected ratio = 0.001obtained abs = 3.72671; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.763280e+05 Mflops = 372.02 -Solve time = 0.00 -Solve flops = 1.675600e+04 Mflops = 491.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00189608; expected ratio = 0.0001obtained abs = 3.40602e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00343896; expected ratio = 0.001obtained abs = 1.03097; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 374.53 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 507.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00141051; expected ratio = 0.0001obtained abs = 2.53387e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00152465; expected ratio = 0.001obtained abs = 0.457136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 373.77 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00121542; expected ratio = 0.0001obtained abs = 2.18342e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00137937; expected ratio = 0.001obtained abs = 0.413391; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 374.72 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116908; expected ratio = 0.0001obtained abs = 2.10016e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00125615; expected ratio = 0.001obtained abs = 0.37659; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 374.53 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 510.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108486; expected ratio = 0.0001obtained abs = 1.94887e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00119693; expected ratio = 0.001obtained abs = 0.358707; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 368.22 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00106217; expected ratio = 0.0001obtained abs = 1.90811e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00113706; expected ratio = 0.001obtained abs = 0.340874; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 365.14 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 479.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00101084; expected ratio = 0.0001obtained abs = 1.8159e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00110289; expected ratio = 0.001obtained abs = 0.330522; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 373.77 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000998567; expected ratio = 0.0001obtained abs = 1.79385e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00106631; expected ratio = 0.001obtained abs = 0.319658; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 373.77 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000965722; expected ratio = 0.0001obtained abs = 1.73486e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00104635; expected ratio = 0.001obtained abs = 0.313576; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 374.53 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 507.06 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000958545; expected ratio = 0.0001obtained abs = 1.72196e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00102306; expected ratio = 0.001obtained abs = 0.306687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 373.77 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 510.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000937102; expected ratio = 0.0001obtained abs = 1.68344e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00101068; expected ratio = 0.001obtained abs = 0.302883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 374.53 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 510.73 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000932645; expected ratio = 0.0001obtained abs = 1.67543e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000995503; expected ratio = 0.001obtained abs = 0.298423; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 373.77 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000918458; expected ratio = 0.0001obtained abs = 1.64995e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00098753; expected ratio = 0.001obtained abs = 0.295945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 373.77 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000915585; expected ratio = 0.0001obtained abs = 1.64478e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000977461; expected ratio = 0.001obtained abs = 0.293013; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 374.53 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000906105; expected ratio = 0.0001obtained abs = 1.62776e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000972243; expected ratio = 0.001obtained abs = 0.291363; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 375.28 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 492.87 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000904212; expected ratio = 0.0001obtained abs = 1.62435e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000965455; expected ratio = 0.001obtained abs = 0.289413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.771600e+05 Mflops = 373.59 -Solve time = 0.00 -Solve flops = 1.680400e+04 Mflops = 496.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00089783; expected ratio = 0.0001obtained abs = 1.61289e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000962028; expected ratio = 0.001obtained abs = 0.288302; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000778427672311 -******** CURRENT TIME = 4.6097720263 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.00562 - Final Residual ratio : 0.00547281 - Residual ratio : 0.000911282 - Slope : -0.181823 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.60977 - DELTA_TIME : 0.000778428 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000772922184358 -******** CURRENT TIME = 4.61054494848 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.51372 - Final Residual ratio : 0.0050493 - Residual ratio : 0.000915771 - Slope : -0.177699 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61054 - DELTA_TIME : 0.000772922 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000767512125093 -******** CURRENT TIME = 4.61131246061 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.16666 - Final Residual ratio : 0.00511975 - Residual ratio : 0.00099092 - Slope : -0.191168 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61131 - DELTA_TIME : 0.000767512 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000762204530735 -******** CURRENT TIME = 4.61207466514 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.18291 - Final Residual ratio : 0.00496101 - Residual ratio : 0.000957187 - Slope : -0.161811 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61207 - DELTA_TIME : 0.000762205 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000757006686643 -******** CURRENT TIME = 4.61283167183 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.3278 - Final Residual ratio : 0.0146214 - Residual ratio : 0.000535037 - Slope : -0.941835 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61283 - DELTA_TIME : 0.000757007 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000751921676196 -******** CURRENT TIME = 4.6135835935 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 297.626 - Final Residual ratio : 0.274549 - Residual ratio : 0.000922463 - Slope : -10.2535 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61358 - DELTA_TIME : 0.000751922 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000746957570491 -******** CURRENT TIME = 4.61433055107 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 362.007 - Final Residual ratio : 0.301586 - Residual ratio : 0.000833095 - Slope : -12.4726 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61433 - DELTA_TIME : 0.000746958 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000742224848097 -******** CURRENT TIME = 4.61507277592 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.2455 - Final Residual ratio : 0.0371561 - Residual ratio : 0.000569481 - Slope : -2.32887 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61507 - DELTA_TIME : 0.000742225 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000737783864377 -******** CURRENT TIME = 4.61581055978 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 57.293 - Final Residual ratio : 0.0408922 - Residual ratio : 0.000713738 - Slope : -1.9084 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61581 - DELTA_TIME : 0.000737784 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000733438167155 -******** CURRENT TIME = 4.61654399795 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 63.3491 - Final Residual ratio : 0.0606965 - Residual ratio : 0.000958126 - Slope : -2.18236 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61654 - DELTA_TIME : 0.000733438 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.61654 - DELTA_TIME : 0.0075504 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 121 - - Mesh vertices: 113 - Mesh triangles: 121 - Mesh edges: 198 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.61654 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.655730e+05 Mflops = 354.68 -Solve time = 0.00 -Solve flops = 1.617000e+04 Mflops = 474.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0487779; expected ratio = 0.0001obtained abs = 0.000893096; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.15203; expected ratio = 0.001obtained abs = 51.1771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.630350e+05 Mflops = 352.12 -Solve time = 0.00 -Solve flops = 1.600800e+04 Mflops = 483.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0181474; expected ratio = 0.0001obtained abs = 0.000328609; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0393304; expected ratio = 0.001obtained abs = 13.6405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.628270e+05 Mflops = 352.40 -Solve time = 0.00 -Solve flops = 1.599200e+04 Mflops = 486.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00616542; expected ratio = 0.0001obtained abs = 0.000111482; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136707; expected ratio = 0.001obtained abs = 4.77519; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.610770e+05 Mflops = 347.89 -Solve time = 0.00 -Solve flops = 1.589600e+04 Mflops = 483.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00282514; expected ratio = 0.0001obtained abs = 5.10443e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00722649; expected ratio = 0.001obtained abs = 2.527; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.610770e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.589600e+04 Mflops = 479.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0018266; expected ratio = 0.0001obtained abs = 3.29945e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00732063; expected ratio = 0.001obtained abs = 2.56356; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.610770e+05 Mflops = 347.18 -Solve time = 0.00 -Solve flops = 1.589600e+04 Mflops = 483.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00155025; expected ratio = 0.0001obtained abs = 2.79992e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00739696; expected ratio = 0.001obtained abs = 2.58856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000438213 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 346.28 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 482.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00158765; expected ratio = 0.0001obtained abs = 2.8674e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00803684; expected ratio = 0.001obtained abs = 2.81557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 346.99 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 466.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00164288; expected ratio = 0.0001obtained abs = 2.96697e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00840593; expected ratio = 0.001obtained abs = 2.94202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 346.99 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 466.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00169983; expected ratio = 0.0001obtained abs = 3.06991e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00876027; expected ratio = 0.001obtained abs = 3.06946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 346.99 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 466.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00176276; expected ratio = 0.0001obtained abs = 3.1834e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00912806; expected ratio = 0.001obtained abs = 3.1948; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000434875 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 346.99 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 482.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00179677; expected ratio = 0.0001obtained abs = 3.24496e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00927531; expected ratio = 0.001obtained abs = 3.2501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 346.99 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 482.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00184207; expected ratio = 0.0001obtained abs = 3.32661e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0095598; expected ratio = 0.001obtained abs = 3.34588; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614310e+05 Mflops = 348.66 -Solve time = 0.00 -Solve flops = 1.591400e+04 Mflops = 466.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00185801; expected ratio = 0.0001obtained abs = 3.35556e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00958642; expected ratio = 0.001obtained abs = 3.35917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 346.81 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 482.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0018829; expected ratio = 0.0001obtained abs = 3.40033e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00975904; expected ratio = 0.001obtained abs = 3.41557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614310e+05 Mflops = 347.94 -Solve time = 0.00 -Solve flops = 1.591400e+04 Mflops = 483.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00188793; expected ratio = 0.0001obtained abs = 3.4096e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00973444; expected ratio = 0.001obtained abs = 3.41105; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 346.99 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 466.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00189808; expected ratio = 0.0001obtained abs = 3.42773e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00981862; expected ratio = 0.001obtained abs = 3.43641; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614310e+05 Mflops = 347.94 -Solve time = 0.00 -Solve flops = 1.591400e+04 Mflops = 483.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00189818; expected ratio = 0.0001obtained abs = 3.42811e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00978335; expected ratio = 0.001obtained abs = 3.42817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 346.28 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 482.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00190058; expected ratio = 0.0001obtained abs = 3.43226e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00981701; expected ratio = 0.001obtained abs = 3.43584; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.614310e+05 Mflops = 348.66 -Solve time = 0.00 -Solve flops = 1.591400e+04 Mflops = 466.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00189926; expected ratio = 0.0001obtained abs = 3.43006e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00978701; expected ratio = 0.001obtained abs = 3.42944; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.609890e+05 Mflops = 342.59 -Solve time = 0.00 -Solve flops = 1.588800e+04 Mflops = 466.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00189869; expected ratio = 0.0001obtained abs = 3.42884e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00979887; expected ratio = 0.001obtained abs = 3.42948; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000729052564192 -******** CURRENT TIME = 4.61727305052 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 55.3423 - Final Residual ratio : 0.0486266 - Residual ratio : 0.000878653 - Slope : -1.90668 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61727 - DELTA_TIME : 0.000729053 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000724665993182 -******** CURRENT TIME = 4.61799771651 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.1904 - Final Residual ratio : 0.0347184 - Residual ratio : 0.000751637 - Slope : -1.53852 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.618 - DELTA_TIME : 0.000724666 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000720342067742 -******** CURRENT TIME = 4.61871805858 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.6087 - Final Residual ratio : 0.0274351 - Residual ratio : 0.000749416 - Slope : -1.21938 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61872 - DELTA_TIME : 0.000720342 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000716137972639 -******** CURRENT TIME = 4.61943419655 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.0279 - Final Residual ratio : 0.0271422 - Residual ratio : 0.000968399 - Slope : -0.933359 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.61943 - DELTA_TIME : 0.000716138 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.0007120801852 -******** CURRENT TIME = 4.62014627673 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.2051 - Final Residual ratio : 0.0181081 - Residual ratio : 0.000815493 - Slope : -0.739565 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62015 - DELTA_TIME : 0.00071208 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000708155066788 -******** CURRENT TIME = 4.6208544318 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.1357 - Final Residual ratio : 0.0170524 - Residual ratio : 0.000846875 - Slope : -0.648988 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62085 - DELTA_TIME : 0.000708155 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.00070432082482 -******** CURRENT TIME = 4.62155875263 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.1502 - Final Residual ratio : 0.0167332 - Residual ratio : 0.000873789 - Slope : -0.617207 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62156 - DELTA_TIME : 0.000704321 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000700534313223 -******** CURRENT TIME = 4.62225928694 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.7645 - Final Residual ratio : 0.0143248 - Residual ratio : 0.000854474 - Slope : -0.540329 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62226 - DELTA_TIME : 0.000700534 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000696771041813 -******** CURRENT TIME = 4.62295605798 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 61.953 - Final Residual ratio : 0.0547408 - Residual ratio : 0.000883587 - Slope : -2.29253 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62296 - DELTA_TIME : 0.000696771 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000693032687643 -******** CURRENT TIME = 4.62364909067 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 51 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 85.4399 - Final Residual ratio : 0.084723 - Residual ratio : 0.000991609 - Slope : -3.0484 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62365 - DELTA_TIME : 0.000693033 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.62365 - DELTA_TIME : 0.00710509 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 121 - - Mesh vertices: 113 - Mesh triangles: 121 - Mesh edges: 198 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.62365 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.639550e+05 Mflops = 350.32 -Solve time = 0.00 -Solve flops = 1.604600e+04 Mflops = 470.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.050276; expected ratio = 0.0001obtained abs = 0.00090556; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.225796; expected ratio = 0.001obtained abs = 66.2915; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.664350e+05 Mflops = 353.28 -Solve time = 0.00 -Solve flops = 1.621000e+04 Mflops = 492.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0164928; expected ratio = 0.0001obtained abs = 0.000299355; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0341951; expected ratio = 0.001obtained abs = 9.93637; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.663270e+05 Mflops = 353.77 -Solve time = 0.00 -Solve flops = 1.619800e+04 Mflops = 478.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00318543; expected ratio = 0.0001obtained abs = 5.78189e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00961225; expected ratio = 0.001obtained abs = 2.78528; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.661170e+05 Mflops = 354.94 -Solve time = 0.00 -Solve flops = 1.618400e+04 Mflops = 478.03 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00151179; expected ratio = 0.0001obtained abs = 2.74447e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00549535; expected ratio = 0.001obtained abs = 1.58969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 354.25 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00111921; expected ratio = 0.0001obtained abs = 2.03189e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00548202; expected ratio = 0.001obtained abs = 1.58651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 353.54 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 492.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00105566; expected ratio = 0.0001obtained abs = 1.91645e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00521026; expected ratio = 0.001obtained abs = 1.50689; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 352.82 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 492.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00103601; expected ratio = 0.0001obtained abs = 1.88083e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00532567; expected ratio = 0.001obtained abs = 1.54129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 348.41 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00101659; expected ratio = 0.0001obtained abs = 1.84553e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00517979; expected ratio = 0.001obtained abs = 1.49819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 353.72 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 474.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00101623; expected ratio = 0.0001obtained abs = 1.84492e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00526479; expected ratio = 0.001obtained abs = 1.52376; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 353.00 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 474.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00101065; expected ratio = 0.0001obtained abs = 1.83473e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.005213; expected ratio = 0.001obtained abs = 1.50786; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 352.82 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 492.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00101383; expected ratio = 0.0001obtained abs = 1.84056e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00527085; expected ratio = 0.001obtained abs = 1.52557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 353.72 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 474.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00101447; expected ratio = 0.0001obtained abs = 1.84168e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00526391; expected ratio = 0.001obtained abs = 1.52261; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 353.00 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 488.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0010177; expected ratio = 0.0001obtained abs = 1.84758e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00529931; expected ratio = 0.001obtained abs = 1.53384; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 353.54 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0010205; expected ratio = 0.0001obtained abs = 1.85261e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00531072; expected ratio = 0.001obtained abs = 1.53617; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 353.54 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00102288; expected ratio = 0.0001obtained abs = 1.85699e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0053299; expected ratio = 0.001obtained abs = 1.54271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 354.25 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00102589; expected ratio = 0.0001obtained abs = 1.8624e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0053464; expected ratio = 0.001obtained abs = 1.54649; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 354.43 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00102741; expected ratio = 0.0001obtained abs = 1.86521e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0053551; expected ratio = 0.001obtained abs = 1.55001; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 353.72 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 474.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0010299; expected ratio = 0.0001obtained abs = 1.86967e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00537084; expected ratio = 0.001obtained abs = 1.55356; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 354.25 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 478.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00103077; expected ratio = 0.0001obtained abs = 1.87131e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00537339; expected ratio = 0.001obtained abs = 1.55531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.662190e+05 Mflops = 353.00 -Solve time = 0.00 -Solve flops = 1.619400e+04 Mflops = 474.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00103258; expected ratio = 0.0001obtained abs = 1.87453e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00538644; expected ratio = 0.001obtained abs = 1.55807; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000659332904561 -******** CURRENT TIME = 4.62430842357 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 166.034 - Final Residual ratio : 0.150286 - Residual ratio : 0.000905152 - Slope : -5.72013 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62431 - DELTA_TIME : 0.000659333 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000658208588579 -******** CURRENT TIME = 4.62496663216 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 233.565 - Final Residual ratio : 0.226014 - Residual ratio : 0.000967668 - Slope : -9.33358 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62497 - DELTA_TIME : 0.000658209 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000657613389582 -******** CURRENT TIME = 4.62562424555 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 215.845 - Final Residual ratio : 0.182943 - Residual ratio : 0.000847568 - Slope : -14.3775 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62562 - DELTA_TIME : 0.000657613 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000656679802867 -******** CURRENT TIME = 4.62628092535 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 146.888 - Final Residual ratio : 0.102557 - Residual ratio : 0.000698197 - Slope : -5.06157 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62628 - DELTA_TIME : 0.00065668 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000655543971828 -******** CURRENT TIME = 4.62693646933 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 51 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 90.8036 - Final Residual ratio : 0.0907218 - Residual ratio : 0.000999098 - Slope : -3.35974 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62694 - DELTA_TIME : 0.000655544 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000654261927463 -******** CURRENT TIME = 4.62759073125 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.9157 - Final Residual ratio : 0.0449819 - Residual ratio : 0.000662319 - Slope : -2.26236 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62759 - DELTA_TIME : 0.000654262 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000652872238904 -******** CURRENT TIME = 4.62824360349 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.4237 - Final Residual ratio : 0.0619043 - Residual ratio : 0.000960893 - Slope : -2.38377 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62824 - DELTA_TIME : 0.000652872 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000651413595911 -******** CURRENT TIME = 4.62889501709 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 60.5217 - Final Residual ratio : 0.0556574 - Residual ratio : 0.000919627 - Slope : -2.32562 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.6289 - DELTA_TIME : 0.000651414 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000649925682964 -******** CURRENT TIME = 4.62954494277 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.6925 - Final Residual ratio : 0.0320824 - Residual ratio : 0.00060886 - Slope : -1.75535 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.62954 - DELTA_TIME : 0.000649926 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.000648444842723 -******** CURRENT TIME = 4.63019338761 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 51 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.8948 - Final Residual ratio : 0.0408484 - Residual ratio : 0.000930597 - Slope : -1.51221 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63019 - DELTA_TIME : 0.000648445 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.63019 - DELTA_TIME : 0.0065443 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 122 - - Mesh vertices: 113 - Mesh triangles: 122 - Mesh edges: 199 - Mesh exterior boundary edges: 32 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 32 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.63019 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.496780e+05 Mflops = 332.52 -Solve time = 0.00 -Solve flops = 1.553800e+04 Mflops = 472.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0355483; expected ratio = 0.0001obtained abs = 0.000652364; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.236601; expected ratio = 0.001obtained abs = 85.7039; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.491580e+05 Mflops = 333.66 -Solve time = 0.00 -Solve flops = 1.549400e+04 Mflops = 457.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0127159; expected ratio = 0.0001obtained abs = 0.000231876; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0352276; expected ratio = 0.001obtained abs = 13.0888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.473400e+05 Mflops = 330.48 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 464.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0034998; expected ratio = 0.0001obtained abs = 6.37996e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.014231; expected ratio = 0.001obtained abs = 5.3254; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.468500e+05 Mflops = 331.50 -Solve time = 0.00 -Solve flops = 1.535600e+04 Mflops = 450.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00134838; expected ratio = 0.0001obtained abs = 2.457e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00453878; expected ratio = 0.001obtained abs = 1.70073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.468500e+05 Mflops = 330.61 -Solve time = 0.00 -Solve flops = 1.535600e+04 Mflops = 466.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000586864; expected ratio = 0.0001obtained abs = 1.06936e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00208318; expected ratio = 0.001obtained abs = 0.780864; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.473400e+05 Mflops = 332.61 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 454.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000413356; expected ratio = 0.0001obtained abs = 7.53193e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00296037; expected ratio = 0.001obtained abs = 1.10914; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.473400e+05 Mflops = 330.48 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 464.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000237492; expected ratio = 0.0001obtained abs = 4.32755e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0010991; expected ratio = 0.001obtained abs = 0.411794; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.473400e+05 Mflops = 331.90 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 467.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000155397; expected ratio = 0.0001obtained abs = 2.83161e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000753354; expected ratio = 0.001obtained abs = 0.282215; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.473400e+05 Mflops = 332.61 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 451.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000104082; expected ratio = 0.0001obtained abs = 1.89659e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000308134; expected ratio = 0.001obtained abs = 0.115432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.473400e+05 Mflops = 332.61 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 467.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00015244; expected ratio = 0.0001obtained abs = 2.77777e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00121642; expected ratio = 0.001obtained abs = 0.455617; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.473400e+05 Mflops = 332.61 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 464.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000105448; expected ratio = 0.0001obtained abs = 1.92148e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000669681; expected ratio = 0.001obtained abs = 0.250847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,122) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.473400e+05 Mflops = 332.61 -Solve time = 0.00 -Solve flops = 1.539000e+04 Mflops = 467.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.92928e-05; expected ratio = 0.0001obtained abs = 1.44488e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000484878; expected ratio = 0.001obtained abs = 0.181619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000646996874884 -******** CURRENT TIME = 4.63084038449 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.1363 - Final Residual ratio : 0.0346404 - Residual ratio : 0.000842089 - Slope : -1.37005 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63084 - DELTA_TIME : 0.000646997 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000645593453335 -******** CURRENT TIME = 4.63148597794 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 55.1691 - Final Residual ratio : 0.0435453 - Residual ratio : 0.000789305 - Slope : -1.83752 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63149 - DELTA_TIME : 0.000645593 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000644226431884 -******** CURRENT TIME = 4.63213020437 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 55.9429 - Final Residual ratio : 0.0414804 - Residual ratio : 0.000741477 - Slope : -1.80327 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63213 - DELTA_TIME : 0.000644226 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.00064287681583 -******** CURRENT TIME = 4.63277308119 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 47.0352 - Final Residual ratio : 0.0355183 - Residual ratio : 0.000755143 - Slope : -1.51612 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63277 - DELTA_TIME : 0.000642877 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000641525341037 -******** CURRENT TIME = 4.63341460653 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 51 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.0913 - Final Residual ratio : 0.0364411 - Residual ratio : 0.000982469 - Slope : -1.54395 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63341 - DELTA_TIME : 0.000641525 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.00064015927697 -******** CURRENT TIME = 4.63405476581 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.5391 - Final Residual ratio : 0.0301215 - Residual ratio : 0.00095505 - Slope : -1.08652 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63405 - DELTA_TIME : 0.000640159 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000638775917079 -******** CURRENT TIME = 4.63469354173 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.394 - Final Residual ratio : 0.0150758 - Residual ratio : 0.000512886 - Slope : -0.979299 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63469 - DELTA_TIME : 0.000638776 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000637377904108 -******** CURRENT TIME = 4.63533091963 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 538.847 - Final Residual ratio : 0.511575 - Residual ratio : 0.000949388 - Slope : -25.635 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63533 - DELTA_TIME : 0.000637378 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.0009366027632 -******** CURRENT TIME = 4.63626752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 460.737 - Final Residual ratio : 0.444763 - Residual ratio : 0.000965331 - Slope : -20.0127 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63627 - DELTA_TIME : 0.000936603 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.63726752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 329.446 - Final Residual ratio : 0.257383 - Residual ratio : 0.000781262 - Slope : -12.1922 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63727 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.63727 - DELTA_TIME : 0.00707413 - NL_ITERATION_NUMBER : 12 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 122 - Number of Conditions : 32 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 121 - - Mesh vertices: 113 - Mesh triangles: 121 - Mesh edges: 198 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.63727 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.472350e+05 Mflops = 336.17 -Solve time = 0.00 -Solve flops = 1.538200e+04 Mflops = 464.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0315624; expected ratio = 0.0001obtained abs = 0.000577322; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.324066; expected ratio = 0.001obtained abs = 95.0766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.501710e+05 Mflops = 334.50 -Solve time = 0.00 -Solve flops = 1.556200e+04 Mflops = 456.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.01135; expected ratio = 0.0001obtained abs = 0.000208255; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0334362; expected ratio = 0.001obtained abs = 9.65845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.503010e+05 Mflops = 342.24 -Solve time = 0.00 -Solve flops = 1.557200e+04 Mflops = 473.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00306538; expected ratio = 0.0001obtained abs = 5.62652e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00922352; expected ratio = 0.001obtained abs = 2.65095; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.495230e+05 Mflops = 340.47 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 471.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000999508; expected ratio = 0.0001obtained abs = 1.83476e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00373891; expected ratio = 0.001obtained abs = 1.07215; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440121 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.495230e+05 Mflops = 340.65 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 468.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000385551; expected ratio = 0.0001obtained abs = 7.07762e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00139926; expected ratio = 0.001obtained abs = 0.401161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.495230e+05 Mflops = 341.40 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 471.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000358999; expected ratio = 0.0001obtained abs = 6.59018e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00184664; expected ratio = 0.001obtained abs = 0.529118; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.495230e+05 Mflops = 341.40 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 485.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000552042; expected ratio = 0.0001obtained abs = 1.0134e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00270848; expected ratio = 0.001obtained abs = 0.776531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439882 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.495230e+05 Mflops = 341.21 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 471.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000821289; expected ratio = 0.0001obtained abs = 1.50764e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0047132; expected ratio = 0.001obtained abs = 1.3498; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000440836 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.503150e+05 Mflops = 342.46 -Solve time = 0.00 -Solve flops = 1.557000e+04 Mflops = 473.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000931412; expected ratio = 0.0001obtained abs = 1.70984e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00458858; expected ratio = 0.001obtained abs = 1.31542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.503150e+05 Mflops = 342.46 -Solve time = 0.00 -Solve flops = 1.557000e+04 Mflops = 473.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00102988; expected ratio = 0.0001obtained abs = 1.89057e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00525877; expected ratio = 0.001obtained abs = 1.50552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437021 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.507570e+05 Mflops = 343.28 -Solve time = 0.00 -Solve flops = 1.559600e+04 Mflops = 474.02 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00115998; expected ratio = 0.0001obtained abs = 2.12946e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00539667; expected ratio = 0.001obtained abs = 1.54699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.503150e+05 Mflops = 341.53 -Solve time = 0.00 -Solve flops = 1.557000e+04 Mflops = 473.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00123433; expected ratio = 0.0001obtained abs = 2.26587e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00588088; expected ratio = 0.001obtained abs = 1.68326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000441074 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.503150e+05 Mflops = 343.20 -Solve time = 0.00 -Solve flops = 1.557000e+04 Mflops = 456.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00131362; expected ratio = 0.0001obtained abs = 2.4115e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00596405; expected ratio = 0.001obtained abs = 1.70959; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.495230e+05 Mflops = 340.65 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 471.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00134598; expected ratio = 0.0001obtained abs = 2.47083e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00620405; expected ratio = 0.001obtained abs = 1.77559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.503150e+05 Mflops = 342.46 -Solve time = 0.00 -Solve flops = 1.557000e+04 Mflops = 473.23 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00137735; expected ratio = 0.0001obtained abs = 2.52851e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0062198; expected ratio = 0.001obtained abs = 1.78288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000435114 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.495230e+05 Mflops = 340.65 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 468.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00138309; expected ratio = 0.0001obtained abs = 2.53895e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00630805; expected ratio = 0.001obtained abs = 1.80531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.503150e+05 Mflops = 341.72 -Solve time = 0.00 -Solve flops = 1.557000e+04 Mflops = 469.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00138737; expected ratio = 0.0001obtained abs = 2.54691e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00628091; expected ratio = 0.001obtained abs = 1.80037; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442028 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.495230e+05 Mflops = 340.65 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 468.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00138397; expected ratio = 0.0001obtained abs = 2.54058e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00630734; expected ratio = 0.001obtained abs = 1.80509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000436068 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.503150e+05 Mflops = 336.97 -Solve time = 0.00 -Solve flops = 1.557000e+04 Mflops = 456.68 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00137932; expected ratio = 0.0001obtained abs = 2.53213e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00627207; expected ratio = 0.001obtained abs = 1.79782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.495230e+05 Mflops = 340.65 -Solve time = 0.00 -Solve flops = 1.552600e+04 Mflops = 471.89 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00137506; expected ratio = 0.0001obtained abs = 2.52421e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00628022; expected ratio = 0.001obtained abs = 1.79733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.63826752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 185.771 - Final Residual ratio : 0.134038 - Residual ratio : 0.000721522 - Slope : -6.87544 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63827 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.63926752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 151.337 - Final Residual ratio : 0.121202 - Residual ratio : 0.000800878 - Slope : -5.40055 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.63927 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.64026752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 77.5458 - Final Residual ratio : 0.0394288 - Residual ratio : 0.000508458 - Slope : -2.42208 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64027 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.64126752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 70.0667 - Final Residual ratio : 0.0395289 - Residual ratio : 0.000564161 - Slope : -2.25894 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64127 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.64226752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.4367 - Final Residual ratio : 0.0453213 - Residual ratio : 0.000672057 - Slope : -2.17392 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64227 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.64326752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 62.5918 - Final Residual ratio : 0.0491343 - Residual ratio : 0.000784996 - Slope : -2.08476 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64327 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.64426752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 56.8636 - Final Residual ratio : 0.041259 - Residual ratio : 0.000725578 - Slope : -1.89408 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64427 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.64526752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 51.9672 - Final Residual ratio : 0.049178 - Residual ratio : 0.000946327 - Slope : -1.79028 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64527 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.64626752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 571.25 - Final Residual ratio : 0.549276 - Residual ratio : 0.000961534 - Slope : -25.941 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64627 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.64726752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 185.745 - Final Residual ratio : 0.181718 - Residual ratio : 0.000978319 - Slope : -6.62725 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64727 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.64727 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 121 - - Mesh vertices: 113 - Mesh triangles: 121 - Mesh edges: 198 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.64727 -matrix_partition : [5](0,48,96,144,194) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.553430e+05 Mflops = 352.38 -Solve time = 0.00 -Solve flops = 1.584200e+04 Mflops = 464.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0519842; expected ratio = 0.0001obtained abs = 0.000984173; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.198852; expected ratio = 0.001obtained abs = 66.987; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000435829 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.549890e+05 Mflops = 353.68 -Solve time = 0.00 -Solve flops = 1.582200e+04 Mflops = 467.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00526632; expected ratio = 0.0001obtained abs = 9.93941e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00573025; expected ratio = 0.001obtained abs = 1.93873; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000438929 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.552410e+05 Mflops = 354.26 -Solve time = 0.00 -Solve flops = 1.583600e+04 Mflops = 481.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000613397; expected ratio = 0.0001obtained abs = 1.15806e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000406932; expected ratio = 0.001obtained abs = 0.137701; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.551450e+05 Mflops = 355.78 -Solve time = 0.00 -Solve flops = 1.583000e+04 Mflops = 481.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000217862; expected ratio = 0.0001obtained abs = 4.11301e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000179949; expected ratio = 0.001obtained abs = 0.0608955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000437975 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.551450e+05 Mflops = 355.01 -Solve time = 0.00 -Solve flops = 1.583000e+04 Mflops = 467.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000126965; expected ratio = 0.0001obtained abs = 2.39698e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.6e-05; expected ratio = 0.001obtained abs = 0.0291032; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,121) -time: 0.000439167 -"finished parallel building" : finished parallel building -matrix size in solver: 194 -RHS size in solver: 194 -Factor time = 0.00 -Factor flops = 1.551450e+05 Mflops = 354.23 -Solve time = 0.00 -Solve flops = 1.583000e+04 Mflops = 477.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.46293e-05; expected ratio = 0.0001obtained abs = 1.59773e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.72712e-05; expected ratio = 0.001obtained abs = 0.0193814; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.64826752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 99.4216 - Final Residual ratio : 0.0807203 - Residual ratio : 0.000811899 - Slope : -4.1392 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64827 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.64926752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 98.2626 - Final Residual ratio : 0.0757796 - Residual ratio : 0.000771194 - Slope : -3.06834 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.64927 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.65026752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 95.3166 - Final Residual ratio : 0.0934856 - Residual ratio : 0.000980791 - Slope : -2.97572 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65027 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.65126752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 81.8987 - Final Residual ratio : 0.0567084 - Residual ratio : 0.000692421 - Slope : -2.27339 - Tolerance : 0.001 - Number of iterations : 36 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65127 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.65226752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.1192 - Final Residual ratio : 0.0528999 - Residual ratio : 0.000825024 - Slope : -2.13554 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65227 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.65326752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.5919 - Final Residual ratio : 0.0361735 - Residual ratio : 0.000744435 - Slope : -1.56632 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65327 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.65426752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.9243 - Final Residual ratio : 0.03433 - Residual ratio : 0.000881968 - Slope : -1.25452 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65427 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.65526752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.6265 - Final Residual ratio : 0.0263584 - Residual ratio : 0.000761223 - Slope : -1.15334 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65527 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.65626752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.6699 - Final Residual ratio : 0.0273196 - Residual ratio : 0.000836231 - Slope : -1.12561 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65627 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.65726752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.7556 - Final Residual ratio : 0.0238148 - Residual ratio : 0.000774325 - Slope : -1.05972 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65727 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.65727 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 113 - Number of Properties : 2 - Number of Elements : 121 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 113 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - - Mesh vertices: 113 - Mesh triangles: 169 - Mesh edges: 281 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 169 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 113 - Input triangles: 121 - - Mesh vertices: 114 - Mesh triangles: 123 - Mesh edges: 201 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.65727 -matrix_partition : [5](0,49,98,147,197) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.539630e+05 Mflops = 325.49 -Solve time = 0.00 -Solve flops = 1.587800e+04 Mflops = 465.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0515041; expected ratio = 0.0001obtained abs = 0.000998978; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.120293; expected ratio = 0.001obtained abs = 36.9; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.567250e+05 Mflops = 332.84 -Solve time = 0.00 -Solve flops = 1.603000e+04 Mflops = 483.70 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0105568; expected ratio = 0.0001obtained abs = 0.000204493; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0206034; expected ratio = 0.001obtained abs = 6.29796; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.583910e+05 Mflops = 339.82 -Solve time = 0.00 -Solve flops = 1.613200e+04 Mflops = 476.50 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00297687; expected ratio = 0.0001obtained abs = 5.76941e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00449985; expected ratio = 0.001obtained abs = 1.37326; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.590890e+05 Mflops = 342.89 -Solve time = 0.00 -Solve flops = 1.617600e+04 Mflops = 477.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000804534; expected ratio = 0.0001obtained abs = 1.55913e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00105062; expected ratio = 0.001obtained abs = 0.320656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.584950e+05 Mflops = 340.91 -Solve time = 0.00 -Solve flops = 1.614200e+04 Mflops = 473.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000383201; expected ratio = 0.0001obtained abs = 7.42603e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000646832; expected ratio = 0.001obtained abs = 0.197375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.583110e+05 Mflops = 340.52 -Solve time = 0.00 -Solve flops = 1.613000e+04 Mflops = 476.44 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000546474; expected ratio = 0.0001obtained abs = 1.05903e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000838173; expected ratio = 0.001obtained abs = 0.255832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.579510e+05 Mflops = 339.05 -Solve time = 0.00 -Solve flops = 1.611000e+04 Mflops = 472.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00072847; expected ratio = 0.0001obtained abs = 1.41169e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00104804; expected ratio = 0.001obtained abs = 0.319773; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.583110e+05 Mflops = 341.04 -Solve time = 0.00 -Solve flops = 1.613000e+04 Mflops = 490.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00090546; expected ratio = 0.0001obtained abs = 1.75474e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00141914; expected ratio = 0.001obtained abs = 0.433221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.584950e+05 Mflops = 340.74 -Solve time = 0.00 -Solve flops = 1.614200e+04 Mflops = 490.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00106567; expected ratio = 0.0001obtained abs = 2.06513e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00165487; expected ratio = 0.001obtained abs = 0.504905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.583110e+05 Mflops = 340.34 -Solve time = 0.00 -Solve flops = 1.613000e+04 Mflops = 490.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116099; expected ratio = 0.0001obtained abs = 2.24995e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00186941; expected ratio = 0.001obtained abs = 0.57073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.584950e+05 Mflops = 341.61 -Solve time = 0.00 -Solve flops = 1.614200e+04 Mflops = 473.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00124563; expected ratio = 0.0001obtained abs = 2.41383e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00201021; expected ratio = 0.001obtained abs = 0.613305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.583110e+05 Mflops = 340.52 -Solve time = 0.00 -Solve flops = 1.613000e+04 Mflops = 490.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00127472; expected ratio = 0.0001obtained abs = 2.47035e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00207175; expected ratio = 0.001obtained abs = 0.632524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.00047183 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.584950e+05 Mflops = 340.74 -Solve time = 0.00 -Solve flops = 1.614200e+04 Mflops = 476.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00130681; expected ratio = 0.0001obtained abs = 2.53238e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00212755; expected ratio = 0.001obtained abs = 0.649101; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.583110e+05 Mflops = 332.67 -Solve time = 0.00 -Solve flops = 1.613000e+04 Mflops = 473.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00130888; expected ratio = 0.0001obtained abs = 2.53655e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00212626; expected ratio = 0.001obtained abs = 0.64917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.584950e+05 Mflops = 340.91 -Solve time = 0.00 -Solve flops = 1.614200e+04 Mflops = 473.46 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00131703; expected ratio = 0.0001obtained abs = 2.55219e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00214064; expected ratio = 0.001obtained abs = 0.653093; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.583110e+05 Mflops = 341.22 -Solve time = 0.00 -Solve flops = 1.613000e+04 Mflops = 473.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00131299; expected ratio = 0.0001obtained abs = 2.54452e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00212704; expected ratio = 0.001obtained abs = 0.649405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.584950e+05 Mflops = 336.43 -Solve time = 0.00 -Solve flops = 1.614200e+04 Mflops = 476.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00131335; expected ratio = 0.0001obtained abs = 2.54505e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00212824; expected ratio = 0.001obtained abs = 0.649308; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.583110e+05 Mflops = 341.22 -Solve time = 0.00 -Solve flops = 1.613000e+04 Mflops = 473.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0013099; expected ratio = 0.0001obtained abs = 2.53854e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00211762; expected ratio = 0.001obtained abs = 0.646527; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.584950e+05 Mflops = 340.74 -Solve time = 0.00 -Solve flops = 1.614200e+04 Mflops = 490.61 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00130878; expected ratio = 0.0001obtained abs = 2.53619e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00211664; expected ratio = 0.001obtained abs = 0.645768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,30,60,90,123) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 197 -RHS size in solver: 197 -Factor time = 0.00 -Factor flops = 1.583110e+05 Mflops = 340.52 -Solve time = 0.00 -Solve flops = 1.613000e+04 Mflops = 473.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00130688; expected ratio = 0.0001obtained abs = 2.53267e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00211046; expected ratio = 0.001obtained abs = 0.644341; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.65826752239 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.3933 - Final Residual ratio : 0.0270962 - Residual ratio : 0.000954316 - Slope : -0.915039 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65827 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.65926752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.252 - Final Residual ratio : 0.021716 - Residual ratio : 0.000859972 - Slope : -0.813881 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.65927 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.66026752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.6971 - Final Residual ratio : 0.0187794 - Residual ratio : 0.000865529 - Slope : -0.747527 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66027 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.66126752239 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.4942 - Final Residual ratio : 0.0156915 - Residual ratio : 0.000848455 - Slope : -0.59608 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66127 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.66226752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3881 - Final Residual ratio : 0.0157841 - Residual ratio : 0.000963144 - Slope : -0.779633 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66227 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.66326752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.6408 - Final Residual ratio : 0.0119109 - Residual ratio : 0.000761523 - Slope : -0.538929 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66327 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.66426752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.9818 - Final Residual ratio : 0.012542 - Residual ratio : 0.000837146 - Slope : -0.482881 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66427 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.66526752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.7364 - Final Residual ratio : 0.00988959 - Residual ratio : 0.000719953 - Slope : -0.473329 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66527 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.66626752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.1708 - Final Residual ratio : 0.00880837 - Residual ratio : 0.000723728 - Slope : -0.434358 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66627 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.66726752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.2536 - Final Residual ratio : 0.00706253 - Residual ratio : 0.00062758 - Slope : -0.362791 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66727 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.66727 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 114 - Number of Properties : 2 - Number of Elements : 123 - Number of Conditions : 33 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 126 - Mesh edges: 206 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.66727 -matrix_partition : [5](0,50,100,150,201) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.561210e+05 Mflops = 330.05 -Solve time = 0.00 -Solve flops = 1.614400e+04 Mflops = 360.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0467979; expected ratio = 0.0001obtained abs = 0.000929615; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0773354; expected ratio = 0.001obtained abs = 24.4696; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.544050e+05 Mflops = 329.91 -Solve time = 0.00 -Solve flops = 1.603800e+04 Mflops = 470.41 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00871373; expected ratio = 0.0001obtained abs = 0.000172397; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0165886; expected ratio = 0.001obtained abs = 5.30808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.553810e+05 Mflops = 333.53 -Solve time = 0.00 -Solve flops = 1.609400e+04 Mflops = 472.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0026608; expected ratio = 0.0001obtained abs = 5.26485e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00502526; expected ratio = 0.001obtained abs = 1.61241; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.553810e+05 Mflops = 332.68 -Solve time = 0.00 -Solve flops = 1.609400e+04 Mflops = 475.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00120801; expected ratio = 0.0001obtained abs = 2.38992e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00356055; expected ratio = 0.001obtained abs = 1.14475; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.553810e+05 Mflops = 333.36 -Solve time = 0.00 -Solve flops = 1.609400e+04 Mflops = 472.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00111145; expected ratio = 0.0001obtained abs = 2.19863e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00292365; expected ratio = 0.001obtained abs = 0.940181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.553810e+05 Mflops = 332.68 -Solve time = 0.00 -Solve flops = 1.609400e+04 Mflops = 472.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0010204; expected ratio = 0.0001obtained abs = 2.01854e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00328559; expected ratio = 0.001obtained abs = 1.05761; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.548370e+05 Mflops = 333.04 -Solve time = 0.00 -Solve flops = 1.606200e+04 Mflops = 471.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108353; expected ratio = 0.0001obtained abs = 2.14327e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00317598; expected ratio = 0.001obtained abs = 1.02189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549870e+05 Mflops = 332.51 -Solve time = 0.00 -Solve flops = 1.607200e+04 Mflops = 474.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108261; expected ratio = 0.0001obtained abs = 2.14155e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00334237; expected ratio = 0.001obtained abs = 1.07619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.548370e+05 Mflops = 332.36 -Solve time = 0.00 -Solve flops = 1.606200e+04 Mflops = 471.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00109522; expected ratio = 0.0001obtained abs = 2.16638e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00330241; expected ratio = 0.001obtained abs = 1.0627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549870e+05 Mflops = 331.83 -Solve time = 0.00 -Solve flops = 1.607200e+04 Mflops = 474.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00109676; expected ratio = 0.0001obtained abs = 2.16951e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00335192; expected ratio = 0.001obtained abs = 1.07934; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.548370e+05 Mflops = 332.87 -Solve time = 0.00 -Solve flops = 1.606200e+04 Mflops = 488.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00109443; expected ratio = 0.0001obtained abs = 2.16479e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00332908; expected ratio = 0.001obtained abs = 1.07132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549870e+05 Mflops = 326.17 -Solve time = 0.00 -Solve flops = 1.607200e+04 Mflops = 474.72 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00109294; expected ratio = 0.0001obtained abs = 2.16197e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00333476; expected ratio = 0.001obtained abs = 1.07383; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.548370e+05 Mflops = 332.19 -Solve time = 0.00 -Solve flops = 1.606200e+04 Mflops = 471.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108817; expected ratio = 0.0001obtained abs = 2.15242e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00331963; expected ratio = 0.001obtained abs = 1.06829; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549870e+05 Mflops = 332.51 -Solve time = 0.00 -Solve flops = 1.607200e+04 Mflops = 458.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108553; expected ratio = 0.0001obtained abs = 2.1473e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00331208; expected ratio = 0.001obtained abs = 1.06653; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.548370e+05 Mflops = 332.36 -Solve time = 0.00 -Solve flops = 1.606200e+04 Mflops = 471.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108162; expected ratio = 0.0001obtained abs = 2.13946e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00330253; expected ratio = 0.001obtained abs = 1.06279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549870e+05 Mflops = 324.38 -Solve time = 0.00 -Solve flops = 1.607200e+04 Mflops = 458.58 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107915; expected ratio = 0.0001obtained abs = 2.13469e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00329305; expected ratio = 0.001obtained abs = 1.0604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.548370e+05 Mflops = 332.36 -Solve time = 0.00 -Solve flops = 1.606200e+04 Mflops = 471.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107658; expected ratio = 0.0001obtained abs = 2.1295e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00328775; expected ratio = 0.001obtained abs = 1.05803; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549870e+05 Mflops = 332.68 -Solve time = 0.00 -Solve flops = 1.607200e+04 Mflops = 471.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107475; expected ratio = 0.0001obtained abs = 2.12597e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00327975; expected ratio = 0.001obtained abs = 1.05612; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.548370e+05 Mflops = 333.04 -Solve time = 0.00 -Solve flops = 1.606200e+04 Mflops = 471.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107324; expected ratio = 0.0001obtained abs = 2.12289e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00327744; expected ratio = 0.001obtained abs = 1.05472; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549870e+05 Mflops = 331.83 -Solve time = 0.00 -Solve flops = 1.607200e+04 Mflops = 471.40 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107203; expected ratio = 0.0001obtained abs = 2.12059e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00327143; expected ratio = 0.001obtained abs = 1.05343; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.66826752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.437 - Final Residual ratio : 0.00970026 - Residual ratio : 0.000848149 - Slope : -0.380909 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66827 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.66926752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.713 - Final Residual ratio : 0.0107414 - Residual ratio : 0.000917045 - Slope : -0.354615 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.66927 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.67026752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.1185 - Final Residual ratio : 0.0106733 - Residual ratio : 0.000959958 - Slope : -0.336601 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67027 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.67126752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.57427 - Final Residual ratio : 0.00852688 - Residual ratio : 0.000890604 - Slope : -0.298929 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67127 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.67226752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.91463 - Final Residual ratio : 0.00686922 - Residual ratio : 0.000867914 - Slope : -0.255089 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67227 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.67326752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.4953 - Final Residual ratio : 0.00554417 - Residual ratio : 0.000739687 - Slope : -0.249659 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67327 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.67426752239 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.371 - Final Residual ratio : 0.0822405 - Residual ratio : 0.000952177 - Slope : -2.97547 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67427 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.67526752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.5295 - Final Residual ratio : 0.0367129 - Residual ratio : 0.000789023 - Slope : -1.66046 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67527 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.67626752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.6896 - Final Residual ratio : 0.0231661 - Residual ratio : 0.000836636 - Slope : -0.922216 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67627 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.67726752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.54377 - Final Residual ratio : 0.00748168 - Residual ratio : 0.00099177 - Slope : -0.243106 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67727 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.67727 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 126 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 126 - Mesh edges: 206 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.67727 -matrix_partition : [5](0,50,100,150,201) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.547350e+05 Mflops = 327.12 -Solve time = 0.00 -Solve flops = 1.605800e+04 Mflops = 474.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0414055; expected ratio = 0.0001obtained abs = 0.000840344; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.1054; expected ratio = 0.001obtained abs = 32.3434; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.547450e+05 Mflops = 329.30 -Solve time = 0.00 -Solve flops = 1.606000e+04 Mflops = 474.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0117416; expected ratio = 0.0001obtained abs = 0.00023751; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0113618; expected ratio = 0.001obtained abs = 3.5098; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.554590e+05 Mflops = 323.92 -Solve time = 0.00 -Solve flops = 1.610200e+04 Mflops = 459.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00183674; expected ratio = 0.0001obtained abs = 3.71473e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00402628; expected ratio = 0.001obtained abs = 1.2432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.554910e+05 Mflops = 331.56 -Solve time = 0.00 -Solve flops = 1.610200e+04 Mflops = 472.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129202; expected ratio = 0.0001obtained abs = 2.61305e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00319054; expected ratio = 0.001obtained abs = 0.985761; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 329.49 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 461.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00112463; expected ratio = 0.0001obtained abs = 2.27436e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00300142; expected ratio = 0.001obtained abs = 0.926738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 331.17 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 471.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00113642; expected ratio = 0.0001obtained abs = 2.29833e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0030167; expected ratio = 0.001obtained abs = 0.93206; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 331.00 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 474.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116899; expected ratio = 0.0001obtained abs = 2.36407e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0030985; expected ratio = 0.001obtained abs = 0.956721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 330.33 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 458.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00119584; expected ratio = 0.0001obtained abs = 2.41849e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00317262; expected ratio = 0.001obtained abs = 0.980272; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 330.33 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 474.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00122961; expected ratio = 0.0001obtained abs = 2.48665e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00323997; expected ratio = 0.001obtained abs = 1.0004; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 330.33 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 471.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00124933; expected ratio = 0.0001obtained abs = 2.52669e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00330426; expected ratio = 0.001obtained abs = 1.02097; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 330.33 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 474.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00126986; expected ratio = 0.0001obtained abs = 2.56803e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0033433; expected ratio = 0.001obtained abs = 1.03231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 330.33 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 471.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0012801; expected ratio = 0.0001obtained abs = 2.5889e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00337886; expected ratio = 0.001obtained abs = 1.04403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 331.00 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 471.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0012895; expected ratio = 0.0001obtained abs = 2.60775e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00339633; expected ratio = 0.001obtained abs = 1.04868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000459194 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 331.00 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 474.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0012934; expected ratio = 0.0001obtained abs = 2.61581e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00341004; expected ratio = 0.001obtained abs = 1.05367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 329.66 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 471.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129675; expected ratio = 0.0001obtained abs = 2.62243e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0034166; expected ratio = 0.001obtained abs = 1.05494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 330.16 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 474.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129772; expected ratio = 0.0001obtained abs = 2.62453e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00341918; expected ratio = 0.001obtained abs = 1.05649; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 330.33 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 471.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0012986; expected ratio = 0.0001obtained abs = 2.62617e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00342186; expected ratio = 0.001obtained abs = 1.05656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 330.33 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 474.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129858; expected ratio = 0.0001obtained abs = 2.62629e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00342026; expected ratio = 0.001obtained abs = 1.05683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 331.68 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 458.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129874; expected ratio = 0.0001obtained abs = 2.62643e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00342216; expected ratio = 0.001obtained abs = 1.05665; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.549150e+05 Mflops = 329.66 -Solve time = 0.00 -Solve flops = 1.607000e+04 Mflops = 471.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00129854; expected ratio = 0.0001obtained abs = 2.62619e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00341952; expected ratio = 0.001obtained abs = 1.0566; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.67826752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.25874 - Final Residual ratio : 0.00807056 - Residual ratio : 0.000977215 - Slope : -0.294667 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67827 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.67926752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.03998 - Final Residual ratio : 0.00719595 - Residual ratio : 0.000796013 - Slope : -0.29138 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.67927 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.68026752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.8697 - Final Residual ratio : 0.0619149 - Residual ratio : 0.000886148 - Slope : -2.40716 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68027 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.68126752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 59.7399 - Final Residual ratio : 0.0570084 - Residual ratio : 0.000954276 - Slope : -2.13153 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68127 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.68226752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 77.7442 - Final Residual ratio : 0.074707 - Residual ratio : 0.000960934 - Slope : -2.87665 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68227 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.68326752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.2582 - Final Residual ratio : 0.0147985 - Residual ratio : 0.000768426 - Slope : -0.663567 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68327 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.68426752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.93902 - Final Residual ratio : 0.00521396 - Residual ratio : 0.000583281 - Slope : -0.372242 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68427 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.68526752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.2947 - Final Residual ratio : 0.00688445 - Residual ratio : 0.000668734 - Slope : -0.342929 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68527 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.68626752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 249.357 - Final Residual ratio : 0.240007 - Residual ratio : 0.000962502 - Slope : -13.1114 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68627 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.68726752239 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 165.996 - Final Residual ratio : 0.158928 - Residual ratio : 0.000957416 - Slope : -10.3648 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68727 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.68727 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 126 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"NODE TOUCHING THE WALL - WILL BE ERASED!!!!" : NODE TOUCHING THE WALL - WILL BE ERASED!!!! -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 114 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - - Mesh vertices: 114 - Mesh triangles: 171 - Mesh edges: 284 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 171 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 114 - Input triangles: 124 - - Mesh vertices: 115 - Mesh triangles: 126 - Mesh edges: 206 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.68727 -matrix_partition : [5](0,50,100,150,201) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.594290e+05 Mflops = 338.58 -Solve time = 0.00 -Solve flops = 1.633000e+04 Mflops = 465.94 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0386812; expected ratio = 0.0001obtained abs = 0.000801691; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0596196; expected ratio = 0.001obtained abs = 18.6892; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.593810e+05 Mflops = 338.99 -Solve time = 0.00 -Solve flops = 1.633000e+04 Mflops = 482.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00704699; expected ratio = 0.0001obtained abs = 0.000145935; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0071511; expected ratio = 0.001obtained abs = 2.24549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 332.89 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 464.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117214; expected ratio = 0.0001obtained abs = 2.42775e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00101957; expected ratio = 0.001obtained abs = 0.320118; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 464.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000503207; expected ratio = 0.0001obtained abs = 1.04226e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000898686; expected ratio = 0.001obtained abs = 0.282281; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000666954; expected ratio = 0.0001obtained abs = 1.3814e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000984751; expected ratio = 0.001obtained abs = 0.309231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 464.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00084489; expected ratio = 0.0001obtained abs = 1.74999e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0013175; expected ratio = 0.001obtained abs = 0.413921; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000976781; expected ratio = 0.0001obtained abs = 2.0231e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0014742; expected ratio = 0.001obtained abs = 0.462931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00108491; expected ratio = 0.0001obtained abs = 2.24713e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0016905; expected ratio = 0.001obtained abs = 0.531159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00113387; expected ratio = 0.0001obtained abs = 2.34846e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00175994; expected ratio = 0.001obtained abs = 0.552663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 464.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116513; expected ratio = 0.0001obtained abs = 2.4133e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00183005; expected ratio = 0.001obtained abs = 0.575024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0011751; expected ratio = 0.0001obtained abs = 2.43385e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00184469; expected ratio = 0.001obtained abs = 0.57928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 337.79 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117904; expected ratio = 0.0001obtained abs = 2.44211e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00185677; expected ratio = 0.001obtained abs = 0.583424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 331.40 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117941; expected ratio = 0.0001obtained abs = 2.44277e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00185789; expected ratio = 0.001obtained abs = 0.583424; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117839; expected ratio = 0.0001obtained abs = 2.44076e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00185678; expected ratio = 0.001obtained abs = 0.583428; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117776; expected ratio = 0.0001obtained abs = 2.43936e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00185674; expected ratio = 0.001obtained abs = 0.583065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 481.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117689; expected ratio = 0.0001obtained abs = 2.43766e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00185449; expected ratio = 0.001obtained abs = 0.582711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 339.17 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 464.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117661; expected ratio = 0.0001obtained abs = 2.43696e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00185507; expected ratio = 0.001obtained abs = 0.582541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 337.79 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117625; expected ratio = 0.0001obtained abs = 2.43633e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00185342; expected ratio = 0.001obtained abs = 0.582374; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 464.85 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0011762; expected ratio = 0.0001obtained abs = 2.43612e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00185438; expected ratio = 0.001obtained abs = 0.582324; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 201 -RHS size in solver: 201 -Factor time = 0.00 -Factor flops = 1.587350e+05 Mflops = 338.48 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 361.55 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117608; expected ratio = 0.0001obtained abs = 2.43597e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00185311; expected ratio = 0.001obtained abs = 0.582276; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.68826752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.9511 - Final Residual ratio : 0.0286205 - Residual ratio : 0.000716388 - Slope : -1.37664 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68827 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.68926752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 183.747 - Final Residual ratio : 0.183347 - Residual ratio : 0.000997824 - Slope : -7.34254 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.68927 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.69026752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.2794 - Final Residual ratio : 0.036272 - Residual ratio : 0.000736049 - Slope : -1.69804 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69027 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.69126752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.6043 - Final Residual ratio : 0.0246434 - Residual ratio : 0.00063836 - Slope : -1.28599 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69127 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.69226752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.7065 - Final Residual ratio : 0.0286041 - Residual ratio : 0.000702692 - Slope : -1.31219 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69227 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.69326752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 145.399 - Final Residual ratio : 0.111598 - Residual ratio : 0.000767535 - Slope : -6.31682 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69327 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.69426752239 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 98.5879 - Final Residual ratio : 0.06181 - Residual ratio : 0.000626953 - Slope : -3.2842 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69427 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000983746640653 -******** CURRENT TIME = 4.69525126903 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 161.291 - Final Residual ratio : 0.131041 - Residual ratio : 0.000812451 - Slope : -8.48212 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69525 - DELTA_TIME : 0.000983747 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000984667457614 -******** CURRENT TIME = 4.69623593649 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.9385 - Final Residual ratio : 0.0304907 - Residual ratio : 0.000825445 - Slope : -1.19058 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69624 - DELTA_TIME : 0.000984667 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000986337313417 -******** CURRENT TIME = 4.6972222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 262.183 - Final Residual ratio : 0.215318 - Residual ratio : 0.00082125 - Slope : -11.3899 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69722 - DELTA_TIME : 0.000986337 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.69722 - DELTA_TIME : 0.00995475 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 126 - Number of Conditions : 34 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 125 - - Mesh vertices: 115 - Mesh triangles: 125 - Mesh edges: 206 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.69722 -matrix_partition : [5](0,50,100,150,202) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.648410e+05 Mflops = 332.24 -Solve time = 0.00 -Solve flops = 1.641600e+04 Mflops = 455.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.042837; expected ratio = 0.0001obtained abs = 0.000911147; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0723249; expected ratio = 0.001obtained abs = 22.4975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.683390e+05 Mflops = 346.96 -Solve time = 0.00 -Solve flops = 1.661600e+04 Mflops = 474.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00520338; expected ratio = 0.0001obtained abs = 0.000110404; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0139072; expected ratio = 0.001obtained abs = 4.36354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.675010e+05 Mflops = 344.73 -Solve time = 0.00 -Solve flops = 1.656800e+04 Mflops = 475.97 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00159244; expected ratio = 0.0001obtained abs = 3.37875e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00276656; expected ratio = 0.001obtained abs = 0.867903; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.684110e+05 Mflops = 346.43 -Solve time = 0.00 -Solve flops = 1.662000e+04 Mflops = 474.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00116777; expected ratio = 0.0001obtained abs = 2.47763e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00226004; expected ratio = 0.001obtained abs = 0.709468; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.680050e+05 Mflops = 346.44 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 473.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00106154; expected ratio = 0.0001obtained abs = 2.25214e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00206518; expected ratio = 0.001obtained abs = 0.648022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.684470e+05 Mflops = 346.50 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 474.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000920424; expected ratio = 0.0001obtained abs = 1.95281e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00179988; expected ratio = 0.001obtained abs = 0.565019; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.680050e+05 Mflops = 344.92 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 476.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000869036; expected ratio = 0.0001obtained abs = 1.84372e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00167688; expected ratio = 0.001obtained abs = 0.52621; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.684470e+05 Mflops = 346.67 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 353.90 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000777251; expected ratio = 0.0001obtained abs = 1.64904e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00149628; expected ratio = 0.001obtained abs = 0.4697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.680050e+05 Mflops = 344.92 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 476.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000748376; expected ratio = 0.0001obtained abs = 1.58773e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0014299; expected ratio = 0.001obtained abs = 0.448717; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.684470e+05 Mflops = 347.18 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 477.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000687249; expected ratio = 0.0001obtained abs = 1.45808e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00130805; expected ratio = 0.001obtained abs = 0.410603; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.680050e+05 Mflops = 345.59 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 473.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000669652; expected ratio = 0.0001obtained abs = 1.42071e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00126733; expected ratio = 0.001obtained abs = 0.397707; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.684470e+05 Mflops = 346.50 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 461.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000627685; expected ratio = 0.0001obtained abs = 1.33171e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118376; expected ratio = 0.001obtained abs = 0.371582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.680050e+05 Mflops = 345.09 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 473.53 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000616108; expected ratio = 0.0001obtained abs = 1.30712e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00115706; expected ratio = 0.001obtained abs = 0.363105; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.684470e+05 Mflops = 346.50 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 477.52 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000586475; expected ratio = 0.0001obtained abs = 1.24427e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00109817; expected ratio = 0.001obtained abs = 0.344709; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.680050e+05 Mflops = 345.59 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 476.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000578414; expected ratio = 0.0001obtained abs = 1.22715e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00107978; expected ratio = 0.001obtained abs = 0.338853; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.684470e+05 Mflops = 346.50 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 461.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000556978; expected ratio = 0.0001obtained abs = 1.18169e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00103722; expected ratio = 0.001obtained abs = 0.325575; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.680050e+05 Mflops = 345.59 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 460.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000551145; expected ratio = 0.0001obtained abs = 1.16929e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0010241; expected ratio = 0.001obtained abs = 0.321381; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.684470e+05 Mflops = 346.67 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 474.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000535326; expected ratio = 0.0001obtained abs = 1.13575e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000992702; expected ratio = 0.001obtained abs = 0.311598; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.680050e+05 Mflops = 345.59 -Solve time = 0.00 -Solve flops = 1.659600e+04 Mflops = 476.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000530996; expected ratio = 0.0001obtained abs = 1.12655e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0009831; expected ratio = 0.001obtained abs = 0.308515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.684470e+05 Mflops = 347.35 -Solve time = 0.00 -Solve flops = 1.662200e+04 Mflops = 474.27 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000519131; expected ratio = 0.0001obtained abs = 1.10139e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000959544; expected ratio = 0.001obtained abs = 0.301189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.6982222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 280.685 - Final Residual ratio : 0.278389 - Residual ratio : 0.000991821 - Slope : -18.6938 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.6992222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 307.833 - Final Residual ratio : 0.270686 - Residual ratio : 0.000879328 - Slope : -11.8293 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.69922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7002222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 193.583 - Final Residual ratio : 0.157391 - Residual ratio : 0.00081304 - Slope : -6.66986 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7012222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 103.004 - Final Residual ratio : 0.0908765 - Residual ratio : 0.000882266 - Slope : -3.67545 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7022222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 47.6637 - Final Residual ratio : 0.0392203 - Residual ratio : 0.000822853 - Slope : -1.70088 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7032222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.3418 - Final Residual ratio : 0.0310333 - Residual ratio : 0.000878089 - Slope : -1.30781 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7042222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.312 - Final Residual ratio : 0.0263519 - Residual ratio : 0.000706258 - Slope : -1.24286 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70422 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7052222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.5195 - Final Residual ratio : 0.0252153 - Residual ratio : 0.000672057 - Slope : -1.24981 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70522 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7062222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.9942 - Final Residual ratio : 0.0229175 - Residual ratio : 0.000654895 - Slope : -1.16571 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70622 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7072222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.6108 - Final Residual ratio : 0.0282924 - Residual ratio : 0.000895022 - Slope : -1.12795 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70722 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.70722 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 125 - - Mesh vertices: 115 - Mesh triangles: 125 - Mesh edges: 206 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.70722 -matrix_partition : [5](0,50,100,150,202) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.650860e+05 Mflops = 340.26 -Solve time = 0.00 -Solve flops = 1.661800e+04 Mflops = 474.16 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0415848; expected ratio = 0.0001obtained abs = 0.000907465; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.135219; expected ratio = 0.001obtained abs = 39.7932; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.650860e+05 Mflops = 339.59 -Solve time = 0.00 -Solve flops = 1.661800e+04 Mflops = 461.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00503214; expected ratio = 0.0001obtained abs = 0.000109543; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00552618; expected ratio = 0.001obtained abs = 1.63187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.656620e+05 Mflops = 343.13 -Solve time = 0.00 -Solve flops = 1.665000e+04 Mflops = 488.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000464056; expected ratio = 0.0001obtained abs = 1.0104e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000476149; expected ratio = 0.001obtained abs = 0.140586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,125) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.656620e+05 Mflops = 342.96 -Solve time = 0.00 -Solve flops = 1.665000e+04 Mflops = 491.80 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.31931e-05; expected ratio = 0.0001obtained abs = 2.02907e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000121556; expected ratio = 0.001obtained abs = 0.0358899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.7082222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.6444 - Final Residual ratio : 0.0267061 - Residual ratio : 0.000932331 - Slope : -1.02206 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7092222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.6012 - Final Residual ratio : 0.0243514 - Residual ratio : 0.000915427 - Slope : -0.857316 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.70922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7102222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.9658 - Final Residual ratio : 0.0215306 - Residual ratio : 0.000862405 - Slope : -0.804654 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7112222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.0772 - Final Residual ratio : 0.0187756 - Residual ratio : 0.0008136 - Slope : -0.743819 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7122222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.8597 - Final Residual ratio : 0.0126418 - Residual ratio : 0.000606036 - Slope : -0.694903 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7132222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.7776 - Final Residual ratio : 0.0145862 - Residual ratio : 0.000776787 - Slope : -0.605258 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7142222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.331 - Final Residual ratio : 0.0110429 - Residual ratio : 0.000637177 - Slope : -0.541248 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71422 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7152222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5389 - Final Residual ratio : 0.0158587 - Residual ratio : 0.000958874 - Slope : -0.516346 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71522 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7162222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.7792 - Final Residual ratio : 0.0135002 - Residual ratio : 0.000855565 - Slope : -0.508572 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71622 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7172222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.6476 - Final Residual ratio : 0.010671 - Residual ratio : 0.00072852 - Slope : -0.443542 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71722 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.71722 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 125 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 126 - - Mesh vertices: 115 - Mesh triangles: 126 - Mesh edges: 207 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.71722 -matrix_partition : [5](0,50,100,150,202) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.634380e+05 Mflops = 341.90 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 472.67 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0891518; expected ratio = 0.0001obtained abs = 0.0020036; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.294888; expected ratio = 0.001obtained abs = 101.757; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.588640e+05 Mflops = 334.33 -Solve time = 0.00 -Solve flops = 1.630600e+04 Mflops = 481.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0249902; expected ratio = 0.0001obtained abs = 0.00055472; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0604804; expected ratio = 0.001obtained abs = 21.565; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.591620e+05 Mflops = 335.13 -Solve time = 0.00 -Solve flops = 1.632200e+04 Mflops = 478.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00367935; expected ratio = 0.0001obtained abs = 8.1597e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0201251; expected ratio = 0.001obtained abs = 7.25267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.586640e+05 Mflops = 334.75 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.001512; expected ratio = 0.0001obtained abs = 3.35117e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00418595; expected ratio = 0.001obtained abs = 1.51262; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.586640e+05 Mflops = 334.75 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 477.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000385807; expected ratio = 0.0001obtained abs = 8.54995e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00142093; expected ratio = 0.001obtained abs = 0.51396; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.586640e+05 Mflops = 329.12 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 481.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000182212; expected ratio = 0.0001obtained abs = 4.03785e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000361806; expected ratio = 0.001obtained abs = 0.130899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.586640e+05 Mflops = 334.75 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 481.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000107943; expected ratio = 0.0001obtained abs = 2.39202e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000212902; expected ratio = 0.001obtained abs = 0.0770377; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.586640e+05 Mflops = 334.75 -Solve time = 0.00 -Solve flops = 1.629200e+04 Mflops = 481.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.394e-05; expected ratio = 0.0001obtained abs = 1.4169e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.49212e-05; expected ratio = 0.001obtained abs = 0.0343472; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.7182222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.1567 - Final Residual ratio : 0.0129549 - Residual ratio : 0.000984661 - Slope : -0.438124 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7192222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0946 - Final Residual ratio : 0.00856222 - Residual ratio : 0.000707936 - Slope : -0.402869 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.71922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7202222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.8703 - Final Residual ratio : 0.0104002 - Residual ratio : 0.000876153 - Slope : -0.370621 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7212222738 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9601 - Final Residual ratio : 0.0082798 - Residual ratio : 0.000692283 - Slope : -0.362177 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7222222738 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.5416 - Final Residual ratio : 0.00820663 - Residual ratio : 0.000711049 - Slope : -0.360418 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7232222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4371 - Final Residual ratio : 0.00625978 - Residual ratio : 0.000599762 - Slope : -0.347695 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7242222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.03775 - Final Residual ratio : 0.00680355 - Residual ratio : 0.000752793 - Slope : -0.301032 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72422 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7252222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.26837 - Final Residual ratio : 0.00710587 - Residual ratio : 0.000859404 - Slope : -0.275375 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72522 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7262222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.31342 - Final Residual ratio : 0.00663514 - Residual ratio : 0.000798124 - Slope : -0.276893 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72622 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7272222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.41104 - Final Residual ratio : 0.00658456 - Residual ratio : 0.000782847 - Slope : -0.280148 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72722 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.72722 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 126 - Number of Conditions : 36 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 126 - - Mesh vertices: 115 - Mesh triangles: 126 - Mesh edges: 207 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.72722 -matrix_partition : [5](0,50,100,150,202) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.00047183 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.611970e+05 Mflops = 336.54 -Solve time = 0.00 -Solve flops = 1.644400e+04 Mflops = 469.19 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0467863; expected ratio = 0.0001obtained abs = 0.00104069; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.579301; expected ratio = 0.001obtained abs = 161.411; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 348.83 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0311812; expected ratio = 0.0001obtained abs = 0.000705084; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0922976; expected ratio = 0.001obtained abs = 25.1788; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00309957; expected ratio = 0.0001obtained abs = 6.99772e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00257292; expected ratio = 0.001obtained abs = 0.702518; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000464201 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 477.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000457189; expected ratio = 0.0001obtained abs = 1.03232e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000420353; expected ratio = 0.001obtained abs = 0.114757; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.23 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000225015; expected ratio = 0.0001obtained abs = 5.0807e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000383607; expected ratio = 0.001obtained abs = 0.104744; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.23 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 477.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000249137; expected ratio = 0.0001obtained abs = 5.62534e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000311897; expected ratio = 0.001obtained abs = 0.0851502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 349.53 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 477.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000243591; expected ratio = 0.0001obtained abs = 5.50016e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000351084; expected ratio = 0.001obtained abs = 0.0958647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000276564; expected ratio = 0.0001obtained abs = 6.2446e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000385996; expected ratio = 0.001obtained abs = 0.105378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.23 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 477.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000297383; expected ratio = 0.0001obtained abs = 6.71474e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000408048; expected ratio = 0.001obtained abs = 0.11142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 351.12 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000311407; expected ratio = 0.0001obtained abs = 7.03134e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000445381; expected ratio = 0.001obtained abs = 0.121588; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 477.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00032376; expected ratio = 0.0001obtained abs = 7.31033e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000449574; expected ratio = 0.001obtained abs = 0.122759; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0003249; expected ratio = 0.0001obtained abs = 7.336e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000461643; expected ratio = 0.001obtained abs = 0.126027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 340.97 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 407.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000327393; expected ratio = 0.0001obtained abs = 7.39236e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000460127; expected ratio = 0.001obtained abs = 0.125641; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000325867; expected ratio = 0.0001obtained abs = 7.35783e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000460168; expected ratio = 0.001obtained abs = 0.125624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 477.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000325316; expected ratio = 0.0001obtained abs = 7.34547e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000458906; expected ratio = 0.001obtained abs = 0.125307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000324532; expected ratio = 0.0001obtained abs = 7.32768e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000457448; expected ratio = 0.001obtained abs = 0.124882; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.23 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 477.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000323984; expected ratio = 0.0001obtained abs = 7.31539e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000457047; expected ratio = 0.001obtained abs = 0.1248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000323856; expected ratio = 0.0001obtained abs = 7.31243e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000456506; expected ratio = 0.001obtained abs = 0.124625; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.94 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000323696; expected ratio = 0.0001obtained abs = 7.30889e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000456431; expected ratio = 0.001obtained abs = 0.124632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000472784 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.660020e+05 Mflops = 350.23 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 477.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000323746; expected ratio = 0.0001obtained abs = 7.30995e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000456465; expected ratio = 0.001obtained abs = 0.124614; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.7282222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.98663 - Final Residual ratio : 0.00738495 - Residual ratio : 0.000924664 - Slope : -0.241795 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7292222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.83575 - Final Residual ratio : 0.00578364 - Residual ratio : 0.000738109 - Slope : -0.25258 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.72922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7302222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.60184 - Final Residual ratio : 0.00603563 - Residual ratio : 0.000793969 - Slope : -0.237369 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 4.7312222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.55937 - Final Residual ratio : 0.00692881 - Residual ratio : 0.000916587 - Slope : -0.236014 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7322222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.62462 - Final Residual ratio : 0.00531694 - Residual ratio : 0.000697338 - Slope : -0.238103 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7332222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.48681 - Final Residual ratio : 0.00640048 - Residual ratio : 0.0008549 - Slope : -0.249347 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7342222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.72954 - Final Residual ratio : 0.00388328 - Residual ratio : 0.000577051 - Slope : -0.224188 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73422 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7352222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.70319 - Final Residual ratio : 0.00358827 - Residual ratio : 0.000629169 - Slope : -0.189987 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73522 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7362222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.10159 - Final Residual ratio : 0.00358805 - Residual ratio : 0.000703321 - Slope : -0.169933 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73622 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7372222738 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.20004 - Final Residual ratio : 0.00450502 - Residual ratio : 0.000866343 - Slope : -0.15744 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73722 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.73722 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 126 - Number of Conditions : 36 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 126 - - Mesh vertices: 115 - Mesh triangles: 126 - Mesh edges: 207 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.73722 -matrix_partition : [5](0,50,100,150,202) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.628370e+05 Mflops = 336.45 -Solve time = 0.00 -Solve flops = 1.656800e+04 Mflops = 448.33 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0441267; expected ratio = 0.0001obtained abs = 0.00102714; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.351665; expected ratio = 0.001obtained abs = 115.831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.581740e+05 Mflops = 331.55 -Solve time = 0.00 -Solve flops = 1.632000e+04 Mflops = 468.84 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0238575; expected ratio = 0.0001obtained abs = 0.000547552; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0258386; expected ratio = 0.001obtained abs = 8.63432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.586620e+05 Mflops = 332.74 -Solve time = 0.00 -Solve flops = 1.634800e+04 Mflops = 454.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00275514; expected ratio = 0.0001obtained abs = 6.324e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00538033; expected ratio = 0.001obtained abs = 1.80248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.583680e+05 Mflops = 332.12 -Solve time = 0.00 -Solve flops = 1.633400e+04 Mflops = 453.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0010123; expected ratio = 0.0001obtained abs = 2.32286e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00202852; expected ratio = 0.001obtained abs = 0.680378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.582060e+05 Mflops = 330.95 -Solve time = 0.00 -Solve flops = 1.632600e+04 Mflops = 465.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000325983; expected ratio = 0.0001obtained abs = 7.47947e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000447984; expected ratio = 0.001obtained abs = 0.150297; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.582060e+05 Mflops = 330.95 -Solve time = 0.00 -Solve flops = 1.632600e+04 Mflops = 465.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.15786e-05; expected ratio = 0.0001obtained abs = 2.10119e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000160222; expected ratio = 0.001obtained abs = 0.0537599; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.7382222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 84.4967 - Final Residual ratio : 0.043579 - Residual ratio : 0.000515748 - Slope : -2.91218 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7392222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 158.58 - Final Residual ratio : 0.152903 - Residual ratio : 0.000964198 - Slope : -5.65812 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.73922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7402222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 124.827 - Final Residual ratio : 0.115946 - Residual ratio : 0.000928856 - Slope : -4.61892 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7412222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 101.678 - Final Residual ratio : 0.0539967 - Residual ratio : 0.000531057 - Slope : -3.38746 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7422222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 84.6209 - Final Residual ratio : 0.0729016 - Residual ratio : 0.000861508 - Slope : -2.81827 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7432222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.4475 - Final Residual ratio : 0.0190076 - Residual ratio : 0.000624275 - Slope : -0.981566 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7442222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.3855 - Final Residual ratio : 0.0259599 - Residual ratio : 0.000801592 - Slope : -1.07865 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74422 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7452222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.2717 - Final Residual ratio : 0.0309839 - Residual ratio : 0.000769371 - Slope : -1.29809 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74522 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7462222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.381 - Final Residual ratio : 0.0300377 - Residual ratio : 0.000743857 - Slope : -1.30164 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74622 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7472222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.601 - Final Residual ratio : 0.0325045 - Residual ratio : 0.000913023 - Slope : -1.31735 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74722 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.74722 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 126 - Number of Conditions : 36 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 126 - - Mesh vertices: 115 - Mesh triangles: 126 - Mesh edges: 207 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.74722 -matrix_partition : [5](0,50,100,150,202) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.568500e+05 Mflops = 325.36 -Solve time = 0.00 -Solve flops = 1.626400e+04 Mflops = 451.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0321731; expected ratio = 0.0001obtained abs = 0.00074316; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.272225; expected ratio = 0.001obtained abs = 77.7954; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.615260e+05 Mflops = 336.56 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 458.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0261199; expected ratio = 0.0001obtained abs = 0.000611353; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0476949; expected ratio = 0.001obtained abs = 13.4145; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.601120e+05 Mflops = 334.94 -Solve time = 0.00 -Solve flops = 1.644800e+04 Mflops = 469.31 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00324553; expected ratio = 0.0001obtained abs = 7.59012e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00589788; expected ratio = 0.001obtained abs = 1.66006; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.615260e+05 Mflops = 327.61 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 458.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000490429; expected ratio = 0.0001obtained abs = 1.14708e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00108234; expected ratio = 0.001obtained abs = 0.304538; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.615260e+05 Mflops = 336.56 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 458.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000132058; expected ratio = 0.0001obtained abs = 3.08875e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000199172; expected ratio = 0.001obtained abs = 0.0560426; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.615260e+05 Mflops = 335.89 -Solve time = 0.00 -Solve flops = 1.651800e+04 Mflops = 471.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.5176e-05; expected ratio = 0.0001obtained abs = 1.29053e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.99633e-05; expected ratio = 0.001obtained abs = 0.0168719; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.7482222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.0174 - Final Residual ratio : 0.0224069 - Residual ratio : 0.000861227 - Slope : -0.928394 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7492222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 165.344 - Final Residual ratio : 0.135906 - Residual ratio : 0.000821956 - Slope : -6.11883 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.74922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7502222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 165.773 - Final Residual ratio : 0.117952 - Residual ratio : 0.000711524 - Slope : -6.37136 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7512222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.4313 - Final Residual ratio : 0.0272642 - Residual ratio : 0.000769494 - Slope : -1.53931 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7522222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.3435 - Final Residual ratio : 0.0142895 - Residual ratio : 0.000823912 - Slope : -0.525127 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7532222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.8483 - Final Residual ratio : 0.0148 - Residual ratio : 0.000709888 - Slope : -0.67205 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7542222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.5376 - Final Residual ratio : 0.0158015 - Residual ratio : 0.00080877 - Slope : -0.697208 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75422 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7552222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.0324 - Final Residual ratio : 0.0114852 - Residual ratio : 0.000716377 - Slope : -0.552445 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75522 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7562222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.335 - Final Residual ratio : 0.0112529 - Residual ratio : 0.000912276 - Slope : -0.456436 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75622 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7572222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.30061 - Final Residual ratio : 0.00714855 - Residual ratio : 0.000768611 - Slope : -0.357441 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75722 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.75722 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 126 - Number of Conditions : 36 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 126 - - Mesh vertices: 115 - Mesh triangles: 126 - Mesh edges: 207 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.75722 -matrix_partition : [5](0,50,100,150,202) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.638890e+05 Mflops = 342.84 -Solve time = 0.00 -Solve flops = 1.665600e+04 Mflops = 462.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.04074; expected ratio = 0.0001obtained abs = 0.000981039; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.185666; expected ratio = 0.001obtained abs = 58.3029; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.632500e+05 Mflops = 343.74 -Solve time = 0.00 -Solve flops = 1.659800e+04 Mflops = 473.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0187528; expected ratio = 0.0001obtained abs = 0.000446728; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0219893; expected ratio = 0.001obtained abs = 6.9957; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.621680e+05 Mflops = 341.46 -Solve time = 0.00 -Solve flops = 1.655200e+04 Mflops = 459.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0023815; expected ratio = 0.0001obtained abs = 5.67172e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00539271; expected ratio = 0.001obtained abs = 1.71881; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.618980e+05 Mflops = 340.72 -Solve time = 0.00 -Solve flops = 1.653800e+04 Mflops = 459.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000763681; expected ratio = 0.0001obtained abs = 1.81828e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00144919; expected ratio = 0.001obtained abs = 0.462116; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.611000e+05 Mflops = 340.58 -Solve time = 0.00 -Solve flops = 1.650000e+04 Mflops = 470.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000199433; expected ratio = 0.0001obtained abs = 4.74816e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000357262; expected ratio = 0.001obtained abs = 0.113937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,31,62,93,126) -time: 0.000475883 -"finished parallel building" : finished parallel building -matrix size in solver: 202 -RHS size in solver: 202 -Factor time = 0.00 -Factor flops = 1.611000e+05 Mflops = 332.20 -Solve time = 0.00 -Solve flops = 1.650000e+04 Mflops = 470.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.38022e-05; expected ratio = 0.0001obtained abs = 1.28092e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.88472e-05; expected ratio = 0.001obtained abs = 0.0283359; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.7582222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.38861 - Final Residual ratio : 0.00497797 - Residual ratio : 0.000673735 - Slope : -0.254608 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7592222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.51144 - Final Residual ratio : 0.00623124 - Residual ratio : 0.000956967 - Slope : -0.224318 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.75922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7602222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.242 - Final Residual ratio : 0.00443742 - Residual ratio : 0.000710897 - Slope : -0.201212 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7612222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.02419 - Final Residual ratio : 0.00373641 - Residual ratio : 0.000620235 - Slope : -0.207602 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7622222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.63152 - Final Residual ratio : 0.004554 - Residual ratio : 0.000808662 - Slope : -0.181515 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7632222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.18798 - Final Residual ratio : 0.0043313 - Residual ratio : 0.000834872 - Slope : -0.167215 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7642222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.932 - Final Residual ratio : 0.06617 - Residual ratio : 0.000761169 - Slope : -3.21725 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76422 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7652222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 85.5891 - Final Residual ratio : 0.0731788 - Residual ratio : 0.000855001 - Slope : -3.16726 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76522 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7662222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.7445 - Final Residual ratio : 0.00838437 - Residual ratio : 0.000713898 - Slope : -0.469445 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76622 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7672222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.3064 - Final Residual ratio : 0.0086729 - Residual ratio : 0.000767079 - Slope : -0.389577 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76722 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.76722 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 115 - Number of Properties : 2 - Number of Elements : 126 - Number of Conditions : 36 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 115 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - - Mesh vertices: 115 - Mesh triangles: 173 - Mesh edges: 287 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 173 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 115 - Input triangles: 127 - - Mesh vertices: 117 - Mesh triangles: 131 - Mesh edges: 215 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 2 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.76722 -matrix_partition : [5](0,52,104,156,209) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.000507116 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.698890e+05 Mflops = 338.99 -Solve time = 0.00 -Solve flops = 1.712800e+04 Mflops = 463.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.031031; expected ratio = 0.0001obtained abs = 0.00073769; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.192877; expected ratio = 0.001obtained abs = 55.6345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.709870e+05 Mflops = 358.59 -Solve time = 0.00 -Solve flops = 1.721000e+04 Mflops = 491.05 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0146631; expected ratio = 0.0001obtained abs = 0.000350237; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0130284; expected ratio = 0.001obtained abs = 3.75875; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.000500917 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.709870e+05 Mflops = 346.79 -Solve time = 0.00 -Solve flops = 1.721000e+04 Mflops = 478.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00168411; expected ratio = 0.0001obtained abs = 4.02011e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00148433; expected ratio = 0.001obtained abs = 0.428534; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.000498056 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.709870e+05 Mflops = 346.79 -Solve time = 0.00 -Solve flops = 1.721000e+04 Mflops = 478.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000183444; expected ratio = 0.0001obtained abs = 4.37917e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00017001; expected ratio = 0.001obtained abs = 0.0490805; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.000495911 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.709870e+05 Mflops = 346.96 -Solve time = 0.00 -Solve flops = 1.721000e+04 Mflops = 478.04 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.91713e-05; expected ratio = 0.0001obtained abs = 4.57655e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.12126e-05; expected ratio = 0.001obtained abs = 0.00612384; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.7682222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4572 - Final Residual ratio : 0.00999969 - Residual ratio : 0.000956245 - Slope : -0.373116 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7692222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 62.7043 - Final Residual ratio : 0.055576 - Residual ratio : 0.000886319 - Slope : -2.61036 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.76922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7702222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.054 - Final Residual ratio : 0.00970707 - Residual ratio : 0.00060465 - Slope : -0.697578 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7712222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.67536 - Final Residual ratio : 0.00691188 - Residual ratio : 0.000796725 - Slope : -0.288948 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7722222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.9412 - Final Residual ratio : 0.00695723 - Residual ratio : 0.000778109 - Slope : -0.308077 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7732222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.34377 - Final Residual ratio : 0.00893886 - Residual ratio : 0.000956665 - Slope : -0.373393 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7742222738 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.2712 - Final Residual ratio : 0.053627 - Residual ratio : 0.000988129 - Slope : -2.08529 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77422 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7752222738 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 142.761 - Final Residual ratio : 0.12072 - Residual ratio : 0.000845607 - Slope : -6.48366 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77522 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7762222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 273.507 - Final Residual ratio : 0.232226 - Residual ratio : 0.000849067 - Slope : -9.42326 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77622 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7772222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 51 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 175.761 - Final Residual ratio : 0.175572 - Residual ratio : 0.000998924 - Slope : -5.66405 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77722 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.77722 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 131 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 131 - - Mesh vertices: 117 - Mesh triangles: 131 - Mesh edges: 215 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.77722 -matrix_partition : [5](0,52,104,156,209) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.00049901 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.714040e+05 Mflops = 338.00 -Solve time = 0.00 -Solve flops = 1.724400e+04 Mflops = 466.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.03434; expected ratio = 0.0001obtained abs = 0.000836896; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0875048; expected ratio = 0.001obtained abs = 26.6617; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.000498056 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.721150e+05 Mflops = 340.84 -Solve time = 0.00 -Solve flops = 1.729800e+04 Mflops = 368.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0127076; expected ratio = 0.0001obtained abs = 0.000307898; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00962135; expected ratio = 0.001obtained abs = 2.95061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.000490904 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.721510e+05 Mflops = 338.83 -Solve time = 0.00 -Solve flops = 1.729600e+04 Mflops = 480.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00185787; expected ratio = 0.0001obtained abs = 4.50209e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00204787; expected ratio = 0.001obtained abs = 0.62799; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.000491858 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.719950e+05 Mflops = 339.32 -Solve time = 0.00 -Solve flops = 1.728400e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000372969; expected ratio = 0.0001obtained abs = 9.03768e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000525047; expected ratio = 0.001obtained abs = 0.160991; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.000491142 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.719950e+05 Mflops = 339.96 -Solve time = 0.00 -Solve flops = 1.728400e+04 Mflops = 480.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000100485; expected ratio = 0.0001obtained abs = 2.43496e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.13074e-05; expected ratio = 0.001obtained abs = 0.0218639; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,32,64,96,131) -time: 0.00048995 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.719950e+05 Mflops = 339.32 -Solve time = 0.00 -Solve flops = 1.728400e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.91367e-05; expected ratio = 0.0001obtained abs = 7.06045e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.56167e-05; expected ratio = 0.001obtained abs = 0.00785438; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.7782222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 100.895 - Final Residual ratio : 0.0878313 - Residual ratio : 0.000870524 - Slope : -3.36023 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7792222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 131.618 - Final Residual ratio : 0.104624 - Residual ratio : 0.00079491 - Slope : -4.38378 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.77922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7802222738 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 124.781 - Final Residual ratio : 0.103499 - Residual ratio : 0.000829444 - Slope : -4.02187 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7812222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 90.3706 - Final Residual ratio : 0.0856554 - Residual ratio : 0.000947823 - Slope : -3.0095 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7822222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 51 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 59.0033 - Final Residual ratio : 0.0473907 - Residual ratio : 0.000803187 - Slope : -2.03296 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7832222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.8091 - Final Residual ratio : 0.0291052 - Residual ratio : 0.000696144 - Slope : -1.44069 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7842222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.3468 - Final Residual ratio : 0.0274021 - Residual ratio : 0.000753906 - Slope : -1.21065 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78422 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7852222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.8639 - Final Residual ratio : 0.025677 - Residual ratio : 0.000781313 - Slope : -1.0593 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78522 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7862222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.7323 - Final Residual ratio : 0.0219451 - Residual ratio : 0.000791321 - Slope : -0.989655 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78622 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7872222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 51 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.9838 - Final Residual ratio : 0.0186547 - Residual ratio : 0.000811645 - Slope : -0.740811 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78722 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.78722 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 131 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 132 - - Mesh vertices: 117 - Mesh triangles: 132 - Mesh edges: 216 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.78722 -matrix_partition : [5](0,52,104,156,209) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.00048399 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.606580e+05 Mflops = 318.15 -Solve time = 0.00 -Solve flops = 1.672200e+04 Mflops = 464.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0291119; expected ratio = 0.0001obtained abs = 0.000714242; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0588323; expected ratio = 0.001obtained abs = 17.491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000477791 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.620600e+05 Mflops = 326.01 -Solve time = 0.00 -Solve flops = 1.682200e+04 Mflops = 467.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00859294; expected ratio = 0.0001obtained abs = 0.000211108; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00934729; expected ratio = 0.001obtained abs = 2.79065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000482082 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.626840e+05 Mflops = 325.39 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 481.00 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00159036; expected ratio = 0.0001obtained abs = 3.90574e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00112075; expected ratio = 0.001obtained abs = 0.334618; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.626840e+05 Mflops = 326.01 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 468.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000212926; expected ratio = 0.0001obtained abs = 5.22951e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00030925; expected ratio = 0.001obtained abs = 0.0923292; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.626840e+05 Mflops = 325.39 -Solve time = 0.00 -Solve flops = 1.685800e+04 Mflops = 468.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.37436e-05; expected ratio = 0.0001obtained abs = 1.07435e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.07946e-05; expected ratio = 0.001obtained abs = 0.00620835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.7882222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.8684 - Final Residual ratio : 0.0173787 - Residual ratio : 0.000759945 - Slope : -0.714094 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78822 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7892222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 212.82 - Final Residual ratio : 0.208767 - Residual ratio : 0.000980956 - Slope : -6.85843 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.78922 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7902222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 87.771 - Final Residual ratio : 0.0821474 - Residual ratio : 0.000935928 - Slope : -2.74028 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.79022 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7912222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.5881 - Final Residual ratio : 0.0299503 - Residual ratio : 0.000756548 - Slope : -1.23619 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.79122 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7922222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.1145 - Final Residual ratio : 0.0338822 - Residual ratio : 0.000888958 - Slope : -1.15396 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.79222 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.7932222738 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.6876 - Final Residual ratio : 0.0306692 - Residual ratio : 0.00079274 - Slope : -1.17142 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.79322 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000995075156073 -******** CURRENT TIME = 4.79421734896 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.7846 - Final Residual ratio : 0.0331072 - Residual ratio : 0.000951777 - Slope : -1.05308 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.79422 - DELTA_TIME : 0.000995075 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000984541173592 -******** CURRENT TIME = 4.79520189013 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.4064 - Final Residual ratio : 0.0270562 - Residual ratio : 0.000889818 - Slope : -0.979979 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.7952 - DELTA_TIME : 0.000984541 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000974355394019 -******** CURRENT TIME = 4.79617624553 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.4396 - Final Residual ratio : 0.0259011 - Residual ratio : 0.000943929 - Slope : -0.945301 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.79618 - DELTA_TIME : 0.000974355 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000964498380882 -******** CURRENT TIME = 4.79714074391 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.4693 - Final Residual ratio : 0.0224312 - Residual ratio : 0.00091671 - Slope : -0.814895 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.79714 - DELTA_TIME : 0.000964498 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.79714 - DELTA_TIME : 0.00991847 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 132 - Number of Conditions : 36 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 132 - - Mesh vertices: 117 - Mesh triangles: 132 - Mesh edges: 216 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.79714 -matrix_partition : [5](0,52,104,156,209) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000483036 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.611920e+05 Mflops = 322.25 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 465.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0304595; expected ratio = 0.0001obtained abs = 0.000760178; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0485151; expected ratio = 0.001obtained abs = 14.6823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.617900e+05 Mflops = 324.84 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 466.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00641071; expected ratio = 0.0001obtained abs = 0.000159497; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00797581; expected ratio = 0.001obtained abs = 2.42881; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.611780e+05 Mflops = 324.39 -Solve time = 0.00 -Solve flops = 1.674600e+04 Mflops = 477.81 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000900481; expected ratio = 0.0001obtained abs = 2.24079e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00123271; expected ratio = 0.001obtained abs = 0.375374; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.00047183 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.617900e+05 Mflops = 324.84 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 482.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000230888; expected ratio = 0.0001obtained abs = 5.74533e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000163967; expected ratio = 0.001obtained abs = 0.0499264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.617900e+05 Mflops = 325.62 -Solve time = 0.00 -Solve flops = 1.678200e+04 Mflops = 466.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.10283e-05; expected ratio = 0.0001obtained abs = 1.51861e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.2716e-05; expected ratio = 0.001obtained abs = 0.00691683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000954931465509 -******** CURRENT TIME = 4.79809567537 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.0082 - Final Residual ratio : 0.0196279 - Residual ratio : 0.000934298 - Slope : -0.655892 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.7981 - DELTA_TIME : 0.000954931 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000945035332753 -******** CURRENT TIME = 4.79904071071 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.5546 - Final Residual ratio : 0.0164505 - Residual ratio : 0.000937106 - Slope : -0.565746 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.79904 - DELTA_TIME : 0.000945035 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000936083583559 -******** CURRENT TIME = 4.79997679429 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.1513 - Final Residual ratio : 0.00928731 - Residual ratio : 0.00061297 - Slope : -0.504734 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.79998 - DELTA_TIME : 0.000936084 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000927409912408 -******** CURRENT TIME = 4.8009042042 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4511 - Final Residual ratio : 0.0107311 - Residual ratio : 0.000797785 - Slope : -0.480013 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.8009 - DELTA_TIME : 0.00092741 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000918990252985 -******** CURRENT TIME = 4.80182319446 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9303 - Final Residual ratio : 0.00905295 - Residual ratio : 0.000758818 - Slope : -0.384558 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.80182 - DELTA_TIME : 0.00091899 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000910803991698 -******** CURRENT TIME = 4.80273399845 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.8283 - Final Residual ratio : 0.00809421 - Residual ratio : 0.000684306 - Slope : -0.381299 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.80273 - DELTA_TIME : 0.000910804 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000902858545798 -******** CURRENT TIME = 4.80363685699 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.7329 - Final Residual ratio : 0.0075974 - Residual ratio : 0.000647531 - Slope : -0.390843 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.80364 - DELTA_TIME : 0.000902859 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000895119807319 -******** CURRENT TIME = 4.8045319768 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.0556 - Final Residual ratio : 0.00993536 - Residual ratio : 0.000898672 - Slope : -0.368189 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.80453 - DELTA_TIME : 0.00089512 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000887571777178 -******** CURRENT TIME = 4.80541954858 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0969 - Final Residual ratio : 0.00716764 - Residual ratio : 0.000709885 - Slope : -0.360347 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.80542 - DELTA_TIME : 0.000887572 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000880210242729 -******** CURRENT TIME = 4.80629975882 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.31182 - Final Residual ratio : 0.00568305 - Residual ratio : 0.000610305 - Slope : -0.300198 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.8063 - DELTA_TIME : 0.00088021 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.8063 - DELTA_TIME : 0.00915901 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 132 - Number of Conditions : 36 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 132 - - Mesh vertices: 117 - Mesh triangles: 132 - Mesh edges: 216 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.8063 -matrix_partition : [5](0,52,104,156,209) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.00048399 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.606920e+05 Mflops = 322.02 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 465.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0269231; expected ratio = 0.0001obtained abs = 0.000678128; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0437534; expected ratio = 0.001obtained abs = 12.9792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.609780e+05 Mflops = 323.99 -Solve time = 0.00 -Solve flops = 1.676200e+04 Mflops = 478.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00402463; expected ratio = 0.0001obtained abs = 0.00010132; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0077139; expected ratio = 0.001obtained abs = 2.30275; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.605380e+05 Mflops = 323.72 -Solve time = 0.00 -Solve flops = 1.674000e+04 Mflops = 477.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00075062; expected ratio = 0.0001obtained abs = 1.88948e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00045863; expected ratio = 0.001obtained abs = 0.136934; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.605380e+05 Mflops = 317.92 -Solve time = 0.00 -Solve flops = 1.674000e+04 Mflops = 464.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.03552e-05; expected ratio = 0.0001obtained abs = 2.27447e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00010716; expected ratio = 0.001obtained abs = 0.0319941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000873033425816 -******** CURRENT TIME = 4.80717279225 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.62807 - Final Residual ratio : 0.00617022 - Residual ratio : 0.000640858 - Slope : -0.310384 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.80717 - DELTA_TIME : 0.000873033 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000866060800343 -******** CURRENT TIME = 4.80803885305 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.98107 - Final Residual ratio : 0.00662153 - Residual ratio : 0.000663409 - Slope : -0.321757 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.80804 - DELTA_TIME : 0.000866061 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.00085926967797 -******** CURRENT TIME = 4.80889812273 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 45.0926 - Final Residual ratio : 0.0335382 - Residual ratio : 0.000743763 - Slope : -1.50197 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.8089 - DELTA_TIME : 0.00085927 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000852645732654 -******** CURRENT TIME = 4.80975076846 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.9326 - Final Residual ratio : 0.0454845 - Residual ratio : 0.000910916 - Slope : -1.72025 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.80975 - DELTA_TIME : 0.000852646 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000846181434002 -******** CURRENT TIME = 4.81059694989 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.1951 - Final Residual ratio : 0.0123359 - Residual ratio : 0.000934886 - Slope : -0.439425 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.8106 - DELTA_TIME : 0.000846181 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000839869375251 -******** CURRENT TIME = 4.81143681927 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.7464 - Final Residual ratio : 0.0151156 - Residual ratio : 0.000959936 - Slope : -0.524377 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81144 - DELTA_TIME : 0.000839869 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000833721990443 -******** CURRENT TIME = 4.81227054126 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.244 - Final Residual ratio : 0.0150906 - Residual ratio : 0.000928991 - Slope : -0.540964 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81227 - DELTA_TIME : 0.000833722 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000827720261507 -******** CURRENT TIME = 4.81309826152 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.1762 - Final Residual ratio : 0.0126633 - Residual ratio : 0.000893281 - Slope : -0.488398 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.8131 - DELTA_TIME : 0.00082772 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000821854451805 -******** CURRENT TIME = 4.81392011597 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9158 - Final Residual ratio : 0.0113038 - Residual ratio : 0.000948643 - Slope : -0.384016 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81392 - DELTA_TIME : 0.000821854 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.0008161195164 -******** CURRENT TIME = 4.81473623549 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.92289 - Final Residual ratio : 0.00863828 - Residual ratio : 0.00087054 - Slope : -0.30982 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81474 - DELTA_TIME : 0.00081612 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.81474 - DELTA_TIME : 0.00843648 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 132 - Number of Conditions : 36 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 132 - - Mesh vertices: 117 - Mesh triangles: 132 - Mesh edges: 216 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.81474 -matrix_partition : [5](0,52,104,156,209) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000482082 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.617350e+05 Mflops = 325.36 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 466.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0254003; expected ratio = 0.0001obtained abs = 0.000646668; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0813796; expected ratio = 0.001obtained abs = 23.8268; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.612750e+05 Mflops = 325.68 -Solve time = 0.00 -Solve flops = 1.675200e+04 Mflops = 481.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00313658; expected ratio = 0.0001obtained abs = 7.9729e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00686641; expected ratio = 0.001obtained abs = 2.02153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000474215 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.615150e+05 Mflops = 326.32 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 478.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000705368; expected ratio = 0.0001obtained abs = 1.79282e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00083052; expected ratio = 0.001obtained abs = 0.244602; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.615150e+05 Mflops = 326.32 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 478.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000163697; expected ratio = 0.0001obtained abs = 4.16046e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000235425; expected ratio = 0.001obtained abs = 0.0693412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,132) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 209 -RHS size in solver: 209 -Factor time = 0.00 -Factor flops = 1.615150e+05 Mflops = 326.16 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 481.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 6.40387e-05; expected ratio = 0.0001obtained abs = 1.62757e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.58585e-05; expected ratio = 0.001obtained abs = 0.0223437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000810510703111 -******** CURRENT TIME = 4.81554674619 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.8273 - Final Residual ratio : 0.00721195 - Residual ratio : 0.000817005 - Slope : -0.284519 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81555 - DELTA_TIME : 0.000810511 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.00080503933196 -******** CURRENT TIME = 4.81635178552 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.10143 - Final Residual ratio : 0.00716464 - Residual ratio : 0.000884367 - Slope : -0.269809 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81635 - DELTA_TIME : 0.000805039 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000799688619281 -******** CURRENT TIME = 4.81715147414 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.90833 - Final Residual ratio : 0.00604524 - Residual ratio : 0.000764414 - Slope : -0.239463 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81715 - DELTA_TIME : 0.000799689 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000794450585612 -******** CURRENT TIME = 4.81794592473 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.55304 - Final Residual ratio : 0.00527165 - Residual ratio : 0.000697951 - Slope : -0.22872 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81795 - DELTA_TIME : 0.000794451 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000789322212889 -******** CURRENT TIME = 4.81873524694 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.55448 - Final Residual ratio : 0.00535846 - Residual ratio : 0.000817526 - Slope : -0.211262 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81874 - DELTA_TIME : 0.000789322 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000784301324385 -******** CURRENT TIME = 4.81951954826 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.51896 - Final Residual ratio : 0.0049367 - Residual ratio : 0.000757284 - Slope : -0.21013 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.81952 - DELTA_TIME : 0.000784301 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000779398992145 -******** CURRENT TIME = 4.82029894726 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.52712 - Final Residual ratio : 0.00491487 - Residual ratio : 0.000752992 - Slope : -0.203819 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.8203 - DELTA_TIME : 0.000779399 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000774600596735 -******** CURRENT TIME = 4.82107354785 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.28996 - Final Residual ratio : 0.0058142 - Residual ratio : 0.000924362 - Slope : -0.19638 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82107 - DELTA_TIME : 0.000774601 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.00076989801872 -******** CURRENT TIME = 4.82184344587 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.80191 - Final Residual ratio : 0.00454512 - Residual ratio : 0.000783383 - Slope : -0.187012 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82184 - DELTA_TIME : 0.000769898 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000765286588893 -******** CURRENT TIME = 4.82260873246 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.26457 - Final Residual ratio : 0.00433993 - Residual ratio : 0.000824365 - Slope : -0.175341 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82261 - DELTA_TIME : 0.000765287 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.82261 - DELTA_TIME : 0.0078725 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 132 - Number of Conditions : 36 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 133 - - Mesh vertices: 117 - Mesh triangles: 133 - Mesh edges: 218 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.82261 -matrix_partition : [5](0,52,104,156,210) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000490904 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.581920e+05 Mflops = 325.57 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 460.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0244191; expected ratio = 0.0001obtained abs = 0.000626168; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119009; expected ratio = 0.001obtained abs = 35.7257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000486135 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.568480e+05 Mflops = 326.65 -Solve time = 0.00 -Solve flops = 1.651000e+04 Mflops = 474.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00291897; expected ratio = 0.0001obtained abs = 7.47211e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0131459; expected ratio = 0.001obtained abs = 3.97906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000488997 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.568480e+05 Mflops = 322.17 -Solve time = 0.00 -Solve flops = 1.651000e+04 Mflops = 458.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000786174; expected ratio = 0.0001obtained abs = 2.01204e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00291845; expected ratio = 0.001obtained abs = 0.884218; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.00048399 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.568480e+05 Mflops = 319.51 -Solve time = 0.00 -Solve flops = 1.651000e+04 Mflops = 474.30 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000228543; expected ratio = 0.0001obtained abs = 5.84859e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000659204; expected ratio = 0.001obtained abs = 0.199769; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000481844 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.568480e+05 Mflops = 327.46 -Solve time = 0.00 -Solve flops = 1.651000e+04 Mflops = 471.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.92597e-05; expected ratio = 0.0001obtained abs = 2.28417e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000207381; expected ratio = 0.001obtained abs = 0.0628511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000760762918 -******** CURRENT TIME = 4.82336949538 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.79001 - Final Residual ratio : 0.00442553 - Residual ratio : 0.00076434 - Slope : -0.180799 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82337 - DELTA_TIME : 0.000760763 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000756337185939 -******** CURRENT TIME = 4.82412583256 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.5661 - Final Residual ratio : 0.00921384 - Residual ratio : 0.000872017 - Slope : -0.329903 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82413 - DELTA_TIME : 0.000756337 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000751997663371 -******** CURRENT TIME = 4.82487783023 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.7518 - Final Residual ratio : 0.04525 - Residual ratio : 0.000826457 - Slope : -1.76473 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82488 - DELTA_TIME : 0.000751998 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000747739016279 -******** CURRENT TIME = 4.82562556924 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.6398 - Final Residual ratio : 0.0581623 - Residual ratio : 0.00081187 - Slope : -2.23693 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82563 - DELTA_TIME : 0.000747739 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000743560216144 -******** CURRENT TIME = 4.82636912946 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.8985 - Final Residual ratio : 0.0170003 - Residual ratio : 0.000854351 - Slope : -0.685568 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82637 - DELTA_TIME : 0.00074356 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000739458564566 -******** CURRENT TIME = 4.82710858803 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.9428 - Final Residual ratio : 0.024915 - Residual ratio : 0.000891641 - Slope : -0.872435 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82711 - DELTA_TIME : 0.000739459 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000735439590755 -******** CURRENT TIME = 4.82784402762 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.9854 - Final Residual ratio : 0.022872 - Residual ratio : 0.000738154 - Slope : -0.967577 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82784 - DELTA_TIME : 0.00073544 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000731492625816 -******** CURRENT TIME = 4.82857552024 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.3588 - Final Residual ratio : 0.0206088 - Residual ratio : 0.000846051 - Slope : -0.785103 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.82858 - DELTA_TIME : 0.000731493 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000727614364558 -******** CURRENT TIME = 4.82930313461 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.6396 - Final Residual ratio : 0.0129393 - Residual ratio : 0.000827341 - Slope : -0.625068 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.8293 - DELTA_TIME : 0.000727614 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000723803624505 -******** CURRENT TIME = 4.83002693823 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.72 - Final Residual ratio : 0.0101668 - Residual ratio : 0.000948398 - Slope : -0.356994 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83003 - DELTA_TIME : 0.000723804 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.83003 - DELTA_TIME : 0.00741821 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 133 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 133 - - Mesh vertices: 117 - Mesh triangles: 133 - Mesh edges: 218 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.83003 -matrix_partition : [5](0,52,104,156,210) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000496864 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.575100e+05 Mflops = 327.54 -Solve time = 0.00 -Solve flops = 1.654000e+04 Mflops = 459.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0218754; expected ratio = 0.0001obtained abs = 0.000563216; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.061435; expected ratio = 0.001obtained abs = 17.9068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000491858 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.577000e+05 Mflops = 328.59 -Solve time = 0.00 -Solve flops = 1.655800e+04 Mflops = 459.93 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00364202; expected ratio = 0.0001obtained abs = 9.38028e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118592; expected ratio = 0.001obtained abs = 3.46875; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000482798 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.581420e+05 Mflops = 329.51 -Solve time = 0.00 -Solve flops = 1.658400e+04 Mflops = 460.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000689163; expected ratio = 0.0001obtained abs = 1.7749e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00247751; expected ratio = 0.001obtained abs = 0.724766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.00048399 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.580940e+05 Mflops = 330.06 -Solve time = 0.00 -Solve flops = 1.658000e+04 Mflops = 460.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000322895; expected ratio = 0.0001obtained abs = 8.31549e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000725079; expected ratio = 0.001obtained abs = 0.212141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000490189 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.580940e+05 Mflops = 323.93 -Solve time = 0.00 -Solve flops = 1.658000e+04 Mflops = 460.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00016689; expected ratio = 0.0001obtained abs = 4.29779e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000473843; expected ratio = 0.001obtained abs = 0.138656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000494003 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.580940e+05 Mflops = 328.75 -Solve time = 0.00 -Solve flops = 1.658000e+04 Mflops = 473.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000103814; expected ratio = 0.0001obtained abs = 2.6734e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000156944; expected ratio = 0.001obtained abs = 0.0459275; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000488043 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.580940e+05 Mflops = 328.59 -Solve time = 0.00 -Solve flops = 1.658000e+04 Mflops = 460.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.65394e-05; expected ratio = 0.0001obtained abs = 1.45598e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000144967; expected ratio = 0.001obtained abs = 0.0424245; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000720058769892 -******** CURRENT TIME = 4.830746997 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3544 - Final Residual ratio : 0.00703994 - Residual ratio : 0.0006799 - Slope : -0.333785 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83075 - DELTA_TIME : 0.000720059 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.000716386370626 -******** CURRENT TIME = 4.83146338337 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.6326 - Final Residual ratio : 0.00927886 - Residual ratio : 0.000963277 - Slope : -0.370128 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83146 - DELTA_TIME : 0.000716386 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000712777213737 -******** CURRENT TIME = 4.83217616059 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.94924 - Final Residual ratio : 0.00711482 - Residual ratio : 0.000895031 - Slope : -0.273867 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83218 - DELTA_TIME : 0.000712777 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000709226833063 -******** CURRENT TIME = 4.83288538742 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.67956 - Final Residual ratio : 0.00570041 - Residual ratio : 0.000853412 - Slope : -0.208558 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83289 - DELTA_TIME : 0.000709227 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000705733454433 -******** CURRENT TIME = 4.83359112087 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.98267 - Final Residual ratio : 0.00399923 - Residual ratio : 0.00066847 - Slope : -0.181172 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83359 - DELTA_TIME : 0.000705733 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000702295975891 -******** CURRENT TIME = 4.83429341685 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.79612 - Final Residual ratio : 0.00562666 - Residual ratio : 0.000970762 - Slope : -0.206803 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83429 - DELTA_TIME : 0.000702296 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000698920488113 -******** CURRENT TIME = 4.83499233734 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.21042 - Final Residual ratio : 0.00458596 - Residual ratio : 0.00088015 - Slope : -0.173528 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83499 - DELTA_TIME : 0.00069892 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.00069560021317 -******** CURRENT TIME = 4.83568793755 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.79746 - Final Residual ratio : 0.00424229 - Residual ratio : 0.000884279 - Slope : -0.159774 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83569 - DELTA_TIME : 0.0006956 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000692331749881 -******** CURRENT TIME = 4.8363802693 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.66314 - Final Residual ratio : 0.0045697 - Residual ratio : 0.000979961 - Slope : -0.155286 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83638 - DELTA_TIME : 0.000692332 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000689113439433 -******** CURRENT TIME = 4.83706938274 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 74.9831 - Final Residual ratio : 0.0703869 - Residual ratio : 0.000938703 - Slope : -4.16181 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83707 - DELTA_TIME : 0.000689113 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.83707 - DELTA_TIME : 0.00704244 - NL_ITERATION_NUMBER : 7 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 133 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 133 - - Mesh vertices: 117 - Mesh triangles: 133 - Mesh edges: 218 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.83707 -matrix_partition : [5](0,52,104,156,210) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000494003 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535900e+05 Mflops = 311.66 -Solve time = 0.00 -Solve flops = 1.638400e+04 Mflops = 440.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0191662; expected ratio = 0.0001obtained abs = 0.000496924; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0429456; expected ratio = 0.001obtained abs = 12.6652; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000488997 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.532300e+05 Mflops = 325.25 -Solve time = 0.00 -Solve flops = 1.635400e+04 Mflops = 469.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00335398; expected ratio = 0.0001obtained abs = 8.67642e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0147187; expected ratio = 0.001obtained abs = 4.38143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000484228 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.526860e+05 Mflops = 324.26 -Solve time = 0.00 -Solve flops = 1.632200e+04 Mflops = 453.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00144779; expected ratio = 0.0001obtained abs = 3.74406e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00444186; expected ratio = 0.001obtained abs = 1.32474; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000483036 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.530840e+05 Mflops = 325.76 -Solve time = 0.00 -Solve flops = 1.634400e+04 Mflops = 466.34 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000660656; expected ratio = 0.0001obtained abs = 1.70817e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0023874; expected ratio = 0.001obtained abs = 0.712678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.00048995 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.530840e+05 Mflops = 324.94 -Solve time = 0.00 -Solve flops = 1.634400e+04 Mflops = 453.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000389642; expected ratio = 0.0001obtained abs = 1.00735e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00134365; expected ratio = 0.001obtained abs = 0.401305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000481129 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.530840e+05 Mflops = 325.76 -Solve time = 0.00 -Solve flops = 1.634400e+04 Mflops = 453.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000226973; expected ratio = 0.0001obtained abs = 5.86766e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000759776; expected ratio = 0.001obtained abs = 0.226986; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000484943 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.530840e+05 Mflops = 325.60 -Solve time = 0.00 -Solve flops = 1.634400e+04 Mflops = 453.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000137254; expected ratio = 0.0001obtained abs = 3.54814e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000480563; expected ratio = 0.001obtained abs = 0.143595; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000488043 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.530840e+05 Mflops = 325.76 -Solve time = 0.00 -Solve flops = 1.634400e+04 Mflops = 453.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.62496e-05; expected ratio = 0.0001obtained abs = 2.22959e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000250219; expected ratio = 0.001obtained abs = 0.0747738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.000685943933673 -******** CURRENT TIME = 4.83775532667 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 121.231 - Final Residual ratio : 0.111879 - Residual ratio : 0.000922859 - Slope : -6.3747 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83776 - DELTA_TIME : 0.000685944 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000682837547475 -******** CURRENT TIME = 4.83843816422 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 298.858 - Final Residual ratio : 0.26524 - Residual ratio : 0.000887513 - Slope : -15.7154 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83844 - DELTA_TIME : 0.000682838 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000678237876843 -******** CURRENT TIME = 4.8391164021 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 84.9814 - Final Residual ratio : 0.0749384 - Residual ratio : 0.000881821 - Slope : -4.71702 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83912 - DELTA_TIME : 0.000678238 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000673093682518 -******** CURRENT TIME = 4.83978949578 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 44.0277 - Final Residual ratio : 0.043458 - Residual ratio : 0.000987061 - Slope : -2.09449 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.83979 - DELTA_TIME : 0.000673094 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000668515086133 -******** CURRENT TIME = 4.84045801087 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.7427 - Final Residual ratio : 0.0321136 - Residual ratio : 0.000850856 - Slope : -1.88553 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84046 - DELTA_TIME : 0.000668515 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000664433881453 -******** CURRENT TIME = 4.84112244475 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.8928 - Final Residual ratio : 0.0300037 - Residual ratio : 0.000859881 - Slope : -2.05075 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84112 - DELTA_TIME : 0.000664434 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000660812041221 -******** CURRENT TIME = 4.84178325679 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.8641 - Final Residual ratio : 0.0315967 - Residual ratio : 0.000991606 - Slope : -2.44866 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84178 - DELTA_TIME : 0.000660812 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000657566355139 -******** CURRENT TIME = 4.84244082314 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.3739 - Final Residual ratio : 0.0271732 - Residual ratio : 0.000957683 - Slope : -1.34984 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84244 - DELTA_TIME : 0.000657566 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000654612102579 -******** CURRENT TIME = 4.84309543525 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.5058 - Final Residual ratio : 0.022509 - Residual ratio : 0.00091852 - Slope : -1.02014 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.8431 - DELTA_TIME : 0.000654612 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000651878850258 -******** CURRENT TIME = 4.8437473141 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.6691 - Final Residual ratio : 0.0190032 - Residual ratio : 0.000919399 - Slope : -0.712073 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84375 - DELTA_TIME : 0.000651879 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.84375 - DELTA_TIME : 0.00667793 - NL_ITERATION_NUMBER : 8 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 133 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 133 - - Mesh vertices: 117 - Mesh triangles: 133 - Mesh edges: 218 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.84375 -matrix_partition : [5](0,52,104,156,210) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000497818 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.530660e+05 Mflops = 325.73 -Solve time = 0.00 -Solve flops = 1.634600e+04 Mflops = 439.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0192162; expected ratio = 0.0001obtained abs = 0.000499151; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0512689; expected ratio = 0.001obtained abs = 14.845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000499964 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.07 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00340837; expected ratio = 0.0001obtained abs = 8.85786e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0074571; expected ratio = 0.001obtained abs = 2.16645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000482082 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.74 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00079881; expected ratio = 0.0001obtained abs = 2.0759e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00319908; expected ratio = 0.001obtained abs = 0.929985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000483036 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.74 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000618703; expected ratio = 0.0001obtained abs = 1.60775e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000663063; expected ratio = 0.001obtained abs = 0.192768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000485182 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.91 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000594415; expected ratio = 0.0001obtained abs = 1.54461e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00211608; expected ratio = 0.001obtained abs = 0.615557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000485182 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.91 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000612263; expected ratio = 0.0001obtained abs = 1.59092e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00072785; expected ratio = 0.001obtained abs = 0.21169; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000487089 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.74 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000591973; expected ratio = 0.0001obtained abs = 1.53821e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00163332; expected ratio = 0.001obtained abs = 0.475255; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.91 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000599031; expected ratio = 0.0001obtained abs = 1.5565e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.001079; expected ratio = 0.001obtained abs = 0.313872; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000497103 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 319.29 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 466.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000582451; expected ratio = 0.0001obtained abs = 1.51345e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00142229; expected ratio = 0.001obtained abs = 0.413895; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000484943 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.07 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000577134; expected ratio = 0.0001obtained abs = 1.49959e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118259; expected ratio = 0.001obtained abs = 0.344029; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000481844 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.74 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000563055; expected ratio = 0.0001obtained abs = 1.46304e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00130383; expected ratio = 0.001obtained abs = 0.379435; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000488043 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.74 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 470.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00055288; expected ratio = 0.0001obtained abs = 1.43656e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118886; expected ratio = 0.001obtained abs = 0.345864; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000479937 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.91 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000542057; expected ratio = 0.0001obtained abs = 1.40847e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00122524; expected ratio = 0.001obtained abs = 0.356569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.00048399 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.07 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 466.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000531899; expected ratio = 0.0001obtained abs = 1.38205e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00116616; expected ratio = 0.001obtained abs = 0.339267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000487089 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.07 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000524501; expected ratio = 0.0001obtained abs = 1.36285e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00117153; expected ratio = 0.001obtained abs = 0.340937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000483036 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 319.13 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000516458; expected ratio = 0.0001obtained abs = 1.34193e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114109; expected ratio = 0.001obtained abs = 0.331975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000487804 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.07 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000512044; expected ratio = 0.0001obtained abs = 1.33048e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00113663; expected ratio = 0.001obtained abs = 0.330782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000478983 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.74 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 454.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000506619; expected ratio = 0.0001obtained abs = 1.31636e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00112232; expected ratio = 0.001obtained abs = 0.326516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000481844 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.07 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 470.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000504491; expected ratio = 0.0001obtained abs = 1.31086e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00111625; expected ratio = 0.001obtained abs = 0.324849; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000481129 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.535420e+05 Mflops = 328.07 -Solve time = 0.00 -Solve flops = 1.636400e+04 Mflops = 466.91 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000501431; expected ratio = 0.0001obtained abs = 1.30288e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0011113; expected ratio = 0.001obtained abs = 0.323312; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.00064931275371 -******** CURRENT TIME = 4.84439662685 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.9097 - Final Residual ratio : 0.0166499 - Residual ratio : 0.000984631 - Slope : -0.62567 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.8444 - DELTA_TIME : 0.000649313 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000646303964903 -******** CURRENT TIME = 4.84504293081 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.7825 - Final Residual ratio : 0.0119711 - Residual ratio : 0.000868573 - Slope : -0.655741 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84504 - DELTA_TIME : 0.000646304 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000643965390382 -******** CURRENT TIME = 4.84568689621 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.3418 - Final Residual ratio : 0.0109719 - Residual ratio : 0.000967387 - Slope : -0.539565 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84569 - DELTA_TIME : 0.000643965 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000641704314761 -******** CURRENT TIME = 4.84632860052 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.62677 - Final Residual ratio : 0.00790006 - Residual ratio : 0.000820634 - Slope : -0.320629 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84633 - DELTA_TIME : 0.000641704 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000639502579972 -******** CURRENT TIME = 4.8469681031 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.51992 - Final Residual ratio : 0.0083516 - Residual ratio : 0.000980244 - Slope : -0.315243 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84697 - DELTA_TIME : 0.000639503 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000637349060131 -******** CURRENT TIME = 4.84760545216 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.71869 - Final Residual ratio : 0.00744885 - Residual ratio : 0.000965041 - Slope : -0.30845 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84761 - DELTA_TIME : 0.000637349 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.00063523530494 -******** CURRENT TIME = 4.84824068747 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 294.825 - Final Residual ratio : 0.259816 - Residual ratio : 0.000881255 - Slope : -29.4565 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84824 - DELTA_TIME : 0.000635235 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000633155363422 -******** CURRENT TIME = 4.84887384283 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 593.56 - Final Residual ratio : 0.569292 - Residual ratio : 0.000959116 - Slope : -53.9082 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84887 - DELTA_TIME : 0.000633155 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.000945777192072 -******** CURRENT TIME = 4.84981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 332.976 - Final Residual ratio : 0.330685 - Residual ratio : 0.000993121 - Slope : -16.6323 - Tolerance : 0.001 - Number of iterations : 20 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.84982 - DELTA_TIME : 0.000945777 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.85081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 241.856 - Final Residual ratio : 0.235616 - Residual ratio : 0.000974199 - Slope : -8.33174 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.85082 - DELTA_TIME : 0.00707231 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 133 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 133 - - Mesh vertices: 117 - Mesh triangles: 133 - Mesh edges: 218 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.85082 -matrix_partition : [5](0,52,104,156,210) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000494957 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.521550e+05 Mflops = 322.32 -Solve time = 0.00 -Solve flops = 1.636000e+04 Mflops = 454.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0196735; expected ratio = 0.0001obtained abs = 0.000516548; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0564709; expected ratio = 0.001obtained abs = 16.7306; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.00048995 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.530410e+05 Mflops = 324.85 -Solve time = 0.00 -Solve flops = 1.641200e+04 Mflops = 471.49 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00249465; expected ratio = 0.0001obtained abs = 6.54504e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00835113; expected ratio = 0.001obtained abs = 2.47856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000482082 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.526630e+05 Mflops = 324.87 -Solve time = 0.00 -Solve flops = 1.638800e+04 Mflops = 455.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000734285; expected ratio = 0.0001obtained abs = 1.92689e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00278023; expected ratio = 0.001obtained abs = 0.823942; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.00048995 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.526630e+05 Mflops = 325.53 -Solve time = 0.00 -Solve flops = 1.638800e+04 Mflops = 455.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000213142; expected ratio = 0.0001obtained abs = 5.59338e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000921482; expected ratio = 0.001obtained abs = 0.272967; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,133) -time: 0.000491142 -"finished parallel building" : finished parallel building -matrix size in solver: 210 -RHS size in solver: 210 -Factor time = 0.00 -Factor flops = 1.521470e+05 Mflops = 318.28 -Solve time = 0.00 -Solve flops = 1.635200e+04 Mflops = 454.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.68136e-05; expected ratio = 0.0001obtained abs = 2.27824e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000217973; expected ratio = 0.001obtained abs = 0.0645625; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.85181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 185.339 - Final Residual ratio : 0.152738 - Residual ratio : 0.000824097 - Slope : -6.38574 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.85281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 128.195 - Final Residual ratio : 0.0981284 - Residual ratio : 0.000765463 - Slope : -5.12387 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.85381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.1254 - Final Residual ratio : 0.0550108 - Residual ratio : 0.000795812 - Slope : -2.38174 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.85481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 55.1075 - Final Residual ratio : 0.0501528 - Residual ratio : 0.00091009 - Slope : -1.96634 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.85581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 47.784 - Final Residual ratio : 0.0282273 - Residual ratio : 0.000590728 - Slope : -1.54051 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.85681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.6226 - Final Residual ratio : 0.0176749 - Residual ratio : 0.000510503 - Slope : -1.11629 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.85781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.6494 - Final Residual ratio : 0.0295148 - Residual ratio : 0.000962981 - Slope : -1.13407 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.85881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.4092 - Final Residual ratio : 0.0220438 - Residual ratio : 0.00077594 - Slope : -0.915714 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.85981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.4371 - Final Residual ratio : 0.0244595 - Residual ratio : 0.000891475 - Slope : -0.945262 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.85982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.86081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.6666 - Final Residual ratio : 0.0246381 - Residual ratio : 0.000923931 - Slope : -0.951498 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.86082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 117 - Number of Properties : 2 - Number of Elements : 133 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 117 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - - Mesh vertices: 117 - Mesh triangles: 177 - Mesh edges: 293 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 177 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 117 - Input triangles: 133 - - Mesh vertices: 118 - Mesh triangles: 135 - Mesh edges: 221 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.86082 -matrix_partition : [5](0,53,106,159,213) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.580870e+05 Mflops = 318.17 -Solve time = 0.00 -Solve flops = 1.678400e+04 Mflops = 454.18 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0295235; expected ratio = 0.0001obtained abs = 0.000784458; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0766691; expected ratio = 0.001obtained abs = 22.5252; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.568190e+05 Mflops = 321.48 -Solve time = 0.00 -Solve flops = 1.671000e+04 Mflops = 464.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00532507; expected ratio = 0.0001obtained abs = 0.000141168; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00731884; expected ratio = 0.001obtained abs = 2.16117; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000507832 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.568190e+05 Mflops = 322.11 -Solve time = 0.00 -Solve flops = 1.671000e+04 Mflops = 452.17 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000524266; expected ratio = 0.0001obtained abs = 1.39013e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000750521; expected ratio = 0.001obtained abs = 0.221604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.568190e+05 Mflops = 321.32 -Solve time = 0.00 -Solve flops = 1.671000e+04 Mflops = 464.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.88826e-05; expected ratio = 0.0001obtained abs = 2.62189e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000165985; expected ratio = 0.001obtained abs = 0.0490133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.86181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.2405 - Final Residual ratio : 0.0174685 - Residual ratio : 0.000665709 - Slope : -0.874101 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.86281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.1124 - Final Residual ratio : 0.0177056 - Residual ratio : 0.000705053 - Slope : -0.836491 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.86381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.8938 - Final Residual ratio : 0.0229136 - Residual ratio : 0.000958979 - Slope : -0.852531 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.86481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.981 - Final Residual ratio : 0.0170092 - Residual ratio : 0.000740142 - Slope : -0.791862 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.86581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.2375 - Final Residual ratio : 0.0208623 - Residual ratio : 0.000938158 - Slope : -1.05794 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.86681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.9418 - Final Residual ratio : 0.0155681 - Residual ratio : 0.000709519 - Slope : -0.756076 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.86781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.2327 - Final Residual ratio : 0.0152026 - Residual ratio : 0.000716 - Slope : -0.70725 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.86881962002 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.3641 - Final Residual ratio : 0.0137629 - Residual ratio : 0.000675842 - Slope : -0.701735 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.86981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.6097 - Final Residual ratio : 0.0143832 - Residual ratio : 0.000733476 - Slope : -0.675699 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.86982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.87081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.0721 - Final Residual ratio : 0.0154284 - Residual ratio : 0.000808951 - Slope : -0.614731 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.87082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 118 - Number of Properties : 2 - Number of Elements : 135 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 118 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - - Mesh vertices: 118 - Mesh triangles: 179 - Mesh edges: 296 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 179 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - Input triangles: 135 - - Mesh vertices: 118 - Mesh triangles: 135 - Mesh edges: 221 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.87082 -matrix_partition : [5](0,53,106,159,213) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.620140e+05 Mflops = 327.17 -Solve time = 0.00 -Solve flops = 1.702000e+04 Mflops = 460.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0278111; expected ratio = 0.0001obtained abs = 0.000751608; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0423793; expected ratio = 0.001obtained abs = 12.3246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000507832 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.615180e+05 Mflops = 327.59 -Solve time = 0.00 -Solve flops = 1.697600e+04 Mflops = 345.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00387619; expected ratio = 0.0001obtained abs = 0.000104556; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00533724; expected ratio = 0.001obtained abs = 1.55897; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.615180e+05 Mflops = 328.38 -Solve time = 0.00 -Solve flops = 1.697600e+04 Mflops = 456.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000450472; expected ratio = 0.0001obtained abs = 1.21524e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000470757; expected ratio = 0.001obtained abs = 0.137478; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.615180e+05 Mflops = 328.22 -Solve time = 0.00 -Solve flops = 1.697600e+04 Mflops = 459.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00010836; expected ratio = 0.0001obtained abs = 2.92323e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00011873; expected ratio = 0.001obtained abs = 0.0346715; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.615180e+05 Mflops = 329.02 -Solve time = 0.00 -Solve flops = 1.697600e+04 Mflops = 459.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 1.1796e-05; expected ratio = 0.0001obtained abs = 3.18222e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.54385e-05; expected ratio = 0.001obtained abs = 0.00742847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.87181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 480.455 - Final Residual ratio : 0.435093 - Residual ratio : 0.000905585 - Slope : -30.0012 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.87281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 282.412 - Final Residual ratio : 0.274985 - Residual ratio : 0.000973701 - Slope : -9.72887 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.87381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 315.242 - Final Residual ratio : 0.282683 - Residual ratio : 0.000896718 - Slope : -14.3163 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.87481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 195.436 - Final Residual ratio : 0.164678 - Residual ratio : 0.000842622 - Slope : -8.1363 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.87581962002 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 104.439 - Final Residual ratio : 0.0829419 - Residual ratio : 0.000794166 - Slope : -4.17424 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.87681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.4852 - Final Residual ratio : 0.0467404 - Residual ratio : 0.000644827 - Slope : -2.7861 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.87781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.8467 - Final Residual ratio : 0.0506334 - Residual ratio : 0.00092318 - Slope : -2.10754 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.87881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 80.1648 - Final Residual ratio : 0.0645435 - Residual ratio : 0.000805135 - Slope : -2.76208 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.87981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.5031 - Final Residual ratio : 0.0572374 - Residual ratio : 0.000661681 - Slope : -2.78857 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.87982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.88081962002 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.6672 - Final Residual ratio : 0.0203823 - Residual ratio : 0.000541115 - Slope : -1.21441 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.88082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 118 - Number of Properties : 2 - Number of Elements : 135 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 118 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - - Mesh vertices: 118 - Mesh triangles: 179 - Mesh edges: 296 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 179 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - Input triangles: 135 - - Mesh vertices: 118 - Mesh triangles: 135 - Mesh edges: 221 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.88082 -matrix_partition : [5](0,53,106,159,213) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.633620e+05 Mflops = 329.42 -Solve time = 0.00 -Solve flops = 1.710200e+04 Mflops = 451.14 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0266956; expected ratio = 0.0001obtained abs = 0.000733457; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0275221; expected ratio = 0.001obtained abs = 8.03129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.633620e+05 Mflops = 331.33 -Solve time = 0.00 -Solve flops = 1.710200e+04 Mflops = 462.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00263058; expected ratio = 0.0001obtained abs = 7.21413e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00577965; expected ratio = 0.001obtained abs = 1.69491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.633620e+05 Mflops = 331.97 -Solve time = 0.00 -Solve flops = 1.710200e+04 Mflops = 462.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00030155; expected ratio = 0.0001obtained abs = 8.27084e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000176457; expected ratio = 0.001obtained abs = 0.0517431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.633620e+05 Mflops = 330.69 -Solve time = 0.00 -Solve flops = 1.710200e+04 Mflops = 462.78 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 2.79928e-05; expected ratio = 0.0001obtained abs = 7.67771e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.7742e-05; expected ratio = 0.001obtained abs = 0.0139993; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.88181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.1731 - Final Residual ratio : 0.0264847 - Residual ratio : 0.000775014 - Slope : -1.17747 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.88281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.9641 - Final Residual ratio : 0.0325387 - Residual ratio : 0.000880279 - Slope : -1.67871 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.88381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.6301 - Final Residual ratio : 0.023976 - Residual ratio : 0.000692345 - Slope : -1.15354 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.88481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.0693 - Final Residual ratio : 0.0232917 - Residual ratio : 0.000801248 - Slope : -0.907688 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.88581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.9775 - Final Residual ratio : 0.0187296 - Residual ratio : 0.000815129 - Slope : -0.740605 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.88681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.9806 - Final Residual ratio : 0.0133161 - Residual ratio : 0.000701566 - Slope : -0.632242 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.88781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.5994 - Final Residual ratio : 0.0134643 - Residual ratio : 0.000765041 - Slope : -0.586199 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.88881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.6153 - Final Residual ratio : 0.00690831 - Residual ratio : 0.000392176 - Slope : -0.568014 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.88981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.452 - Final Residual ratio : 0.0147056 - Residual ratio : 0.000842627 - Slope : -0.581245 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.88982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.89081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.449 - Final Residual ratio : 0.0157899 - Residual ratio : 0.00095993 - Slope : -0.513539 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.89082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 118 - Number of Properties : 2 - Number of Elements : 135 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 118 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - - Mesh vertices: 118 - Mesh triangles: 179 - Mesh edges: 296 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 179 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - Input triangles: 135 - - Mesh vertices: 118 - Mesh triangles: 135 - Mesh edges: 221 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.89082 -matrix_partition : [5](0,53,106,159,213) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.579090e+05 Mflops = 313.30 -Solve time = 0.00 -Solve flops = 1.673200e+04 Mflops = 452.77 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0302171; expected ratio = 0.0001obtained abs = 0.000843424; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.122449; expected ratio = 0.001obtained abs = 35.7487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.583310e+05 Mflops = 315.93 -Solve time = 0.00 -Solve flops = 1.674800e+04 Mflops = 453.20 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00304752; expected ratio = 0.0001obtained abs = 8.48853e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0088169; expected ratio = 0.001obtained abs = 2.58614; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.580370e+05 Mflops = 314.75 -Solve time = 0.00 -Solve flops = 1.673400e+04 Mflops = 452.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000397883; expected ratio = 0.0001obtained abs = 1.10832e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00091926; expected ratio = 0.001obtained abs = 0.269622; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.580370e+05 Mflops = 314.75 -Solve time = 0.00 -Solve flops = 1.673400e+04 Mflops = 452.82 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 5.12416e-05; expected ratio = 0.0001obtained abs = 1.42732e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000152985; expected ratio = 0.001obtained abs = 0.0448715; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.89181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 145.445 - Final Residual ratio : 0.142476 - Residual ratio : 0.000979585 - Slope : -5.18938 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.89281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 113.316 - Final Residual ratio : 0.0961184 - Residual ratio : 0.000848235 - Slope : -3.90413 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.89381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 100.306 - Final Residual ratio : 0.0934049 - Residual ratio : 0.000931195 - Slope : -5.27437 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.89481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.6907 - Final Residual ratio : 0.0691771 - Residual ratio : 0.000951664 - Slope : -2.50419 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.89581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.3594 - Final Residual ratio : 0.0488054 - Residual ratio : 0.000969142 - Slope : -1.79681 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.89681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.8175 - Final Residual ratio : 0.0327566 - Residual ratio : 0.00091454 - Slope : -1.23396 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.89781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.6871 - Final Residual ratio : 0.0264153 - Residual ratio : 0.000954065 - Slope : -0.953817 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.89881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.7901 - Final Residual ratio : 0.0192489 - Residual ratio : 0.000809112 - Slope : -0.74284 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.89981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.7567 - Final Residual ratio : 0.0185673 - Residual ratio : 0.000853407 - Slope : -0.724605 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.89982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.90081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.1057 - Final Residual ratio : 0.0136401 - Residual ratio : 0.000678416 - Slope : -0.692831 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.90082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 118 - Number of Properties : 2 - Number of Elements : 135 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 118 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - - Mesh vertices: 118 - Mesh triangles: 179 - Mesh edges: 296 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 179 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - Input triangles: 135 - - Mesh vertices: 118 - Mesh triangles: 135 - Mesh edges: 221 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.90082 -matrix_partition : [5](0,53,106,159,213) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.581310e+05 Mflops = 313.74 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 453.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0240468; expected ratio = 0.0001obtained abs = 0.000679423; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.119953; expected ratio = 0.001obtained abs = 35.8232; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.581310e+05 Mflops = 315.68 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 465.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00249658; expected ratio = 0.0001obtained abs = 7.04789e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00832957; expected ratio = 0.001obtained abs = 2.50358; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.581310e+05 Mflops = 306.92 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 453.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000524187; expected ratio = 0.0001obtained abs = 1.47984e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000781666; expected ratio = 0.001obtained abs = 0.234937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.581310e+05 Mflops = 315.08 -Solve time = 0.00 -Solve flops = 1.675000e+04 Mflops = 453.26 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 7.89778e-05; expected ratio = 0.0001obtained abs = 2.22962e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000162653; expected ratio = 0.001obtained abs = 0.0488869; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.90181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.4443 - Final Residual ratio : 0.0171878 - Residual ratio : 0.000931872 - Slope : -0.682487 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.90281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.6678 - Final Residual ratio : 0.0138065 - Residual ratio : 0.000828337 - Slope : -0.537225 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.90381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.0446 - Final Residual ratio : 0.0150064 - Residual ratio : 0.000997457 - Slope : -0.518262 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.90481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.7852 - Final Residual ratio : 0.0127041 - Residual ratio : 0.000921572 - Slope : -0.474915 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.90581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.863 - Final Residual ratio : 0.00319568 - Residual ratio : 0.00024844 - Slope : -0.443442 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.90681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.1428 - Final Residual ratio : 0.00935073 - Residual ratio : 0.000770065 - Slope : -0.404448 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.90781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.2974 - Final Residual ratio : 0.00930528 - Residual ratio : 0.000823663 - Slope : -0.364133 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.90881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3832 - Final Residual ratio : 0.0080027 - Residual ratio : 0.000770733 - Slope : -0.334685 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.90981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.62296 - Final Residual ratio : 0.00796393 - Residual ratio : 0.000827597 - Slope : -0.3205 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.90982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.91081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.16064 - Final Residual ratio : 0.00736933 - Residual ratio : 0.000804456 - Slope : -0.305109 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.91082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 4 - - Mesh 0 : - Number of Nodes : 118 - Number of Properties : 2 - Number of Elements : 135 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 118 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - - Mesh vertices: 118 - Mesh triangles: 179 - Mesh edges: 296 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 179 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - Input triangles: 135 - - Mesh vertices: 118 - Mesh triangles: 135 - Mesh edges: 221 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.91082 -matrix_partition : [5](0,53,106,159,213) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.590980e+05 Mflops = 311.97 -Solve time = 0.00 -Solve flops = 1.674400e+04 Mflops = 453.09 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0218706; expected ratio = 0.0001obtained abs = 0.000625566; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.11708; expected ratio = 0.001obtained abs = 33.1202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.593700e+05 Mflops = 313.68 -Solve time = 0.00 -Solve flops = 1.675800e+04 Mflops = 465.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00272968; expected ratio = 0.0001obtained abs = 7.79434e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00786068; expected ratio = 0.001obtained abs = 2.23781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.594660e+05 Mflops = 314.60 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 453.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000603911; expected ratio = 0.0001obtained abs = 1.72444e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000737799; expected ratio = 0.001obtained abs = 0.210123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.594660e+05 Mflops = 313.87 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 465.65 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000129841; expected ratio = 0.0001obtained abs = 3.70746e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000206875; expected ratio = 0.001obtained abs = 0.0589238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,33,66,99,135) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 213 -RHS size in solver: 213 -Factor time = 0.00 -Factor flops = 1.594660e+05 Mflops = 313.28 -Solve time = 0.00 -Solve flops = 1.676400e+04 Mflops = 453.63 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 4.54295e-05; expected ratio = 0.0001obtained abs = 1.29718e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.77414e-05; expected ratio = 0.001obtained abs = 0.0192953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.91181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.94178 - Final Residual ratio : 0.00694788 - Residual ratio : 0.000777013 - Slope : -0.308098 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.91281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.65003 - Final Residual ratio : 0.00795251 - Residual ratio : 0.000919363 - Slope : -0.288069 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.91381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.20136 - Final Residual ratio : 0.00570698 - Residual ratio : 0.000695858 - Slope : -0.264376 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.91481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.70031 - Final Residual ratio : 0.00707308 - Residual ratio : 0.000918545 - Slope : -0.265284 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.91581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.31718 - Final Residual ratio : 0.00647801 - Residual ratio : 0.000885315 - Slope : -0.252093 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.91681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.07818 - Final Residual ratio : 0.00681569 - Residual ratio : 0.000962915 - Slope : -0.235712 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.91781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.82987 - Final Residual ratio : 0.00672077 - Residual ratio : 0.000984027 - Slope : -0.220102 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.91881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.47923 - Final Residual ratio : 0.0056285 - Residual ratio : 0.000868699 - Slope : -0.208826 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.91981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.08996 - Final Residual ratio : 0.00566544 - Residual ratio : 0.000930293 - Slope : -0.20281 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.91982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.92081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.80859 - Final Residual ratio : 0.00398456 - Residual ratio : 0.000685976 - Slope : -0.223254 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.92082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 118 - Number of Properties : 2 - Number of Elements : 135 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 118 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - - Mesh vertices: 118 - Mesh triangles: 179 - Mesh edges: 296 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 179 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 118 - Input triangles: 135 - - Mesh vertices: 119 - Mesh triangles: 137 - Mesh edges: 224 - Mesh exterior boundary edges: 37 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 37 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.92082 -matrix_partition : [5](0,54,108,162,216) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,34,68,102,137) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 216 -RHS size in solver: 216 -Factor time = 0.00 -Factor flops = 1.526330e+05 Mflops = 305.87 -Solve time = 0.00 -Solve flops = 1.661200e+04 Mflops = 446.64 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0199123; expected ratio = 0.0001obtained abs = 0.000574834; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0726485; expected ratio = 0.001obtained abs = 21.2284; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,137) -time: 0.000495911 -"finished parallel building" : finished parallel building -matrix size in solver: 216 -RHS size in solver: 216 -Factor time = 0.00 -Factor flops = 1.538210e+05 Mflops = 310.78 -Solve time = 0.00 -Solve flops = 1.668200e+04 Mflops = 451.42 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00283267; expected ratio = 0.0001obtained abs = 8.17059e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00896282; expected ratio = 0.001obtained abs = 2.63417; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,137) -time: 0.00049901 -"finished parallel building" : finished parallel building -matrix size in solver: 216 -RHS size in solver: 216 -Factor time = 0.00 -Factor flops = 1.540150e+05 Mflops = 311.17 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 463.32 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000711451; expected ratio = 0.0001obtained abs = 2.05213e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00123355; expected ratio = 0.001obtained abs = 0.362578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,137) -time: 0.000498056 -"finished parallel building" : finished parallel building -matrix size in solver: 216 -RHS size in solver: 216 -Factor time = 0.00 -Factor flops = 1.540150e+05 Mflops = 312.37 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 451.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000206379; expected ratio = 0.0001obtained abs = 5.95284e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000322398; expected ratio = 0.001obtained abs = 0.0947686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,137) -time: 0.000494957 -"finished parallel building" : finished parallel building -matrix size in solver: 216 -RHS size in solver: 216 -Factor time = 0.00 -Factor flops = 1.540150e+05 Mflops = 311.02 -Solve time = 0.00 -Solve flops = 1.668000e+04 Mflops = 451.36 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.01584e-05; expected ratio = 0.0001obtained abs = 2.31209e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.96539e-05; expected ratio = 0.001obtained abs = 0.0292942; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.92181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.72121 - Final Residual ratio : 0.00470699 - Residual ratio : 0.000822726 - Slope : -0.19055 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.92281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.65924 - Final Residual ratio : 0.00560775 - Residual ratio : 0.000990903 - Slope : -0.188454 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.92381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.49411 - Final Residual ratio : 0.00439235 - Residual ratio : 0.000799464 - Slope : -0.177088 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.92481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.47537 - Final Residual ratio : 0.00476086 - Residual ratio : 0.000735227 - Slope : -0.223124 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.92581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.5991 - Final Residual ratio : 0.0262321 - Residual ratio : 0.000986202 - Slope : -0.916304 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.92681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 53.4858 - Final Residual ratio : 0.0510651 - Residual ratio : 0.000954741 - Slope : -1.84258 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.92781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.2508 - Final Residual ratio : 0.0317361 - Residual ratio : 0.000984039 - Slope : -1.23919 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.92881962002 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.6654 - Final Residual ratio : 0.0162831 - Residual ratio : 0.000872368 - Slope : -0.666041 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.92981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4477 - Final Residual ratio : 0.0117645 - Residual ratio : 0.000874831 - Slope : -0.40715 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.92982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.93081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.2339 - Final Residual ratio : 0.0115008 - Residual ratio : 0.000807988 - Slope : -0.430981 - Tolerance : 0.001 - Number of iterations : 33 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.93082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 119 - Number of Properties : 2 - Number of Elements : 137 - Number of Conditions : 37 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 119 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 119 - - Mesh vertices: 119 - Mesh triangles: 181 - Mesh edges: 299 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 181 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 119 - Input triangles: 136 - - Mesh vertices: 120 - Mesh triangles: 138 - Mesh edges: 226 - Mesh exterior boundary edges: 38 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 38 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.93082 -matrix_partition : [5](0,54,108,162,219) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.478370e+05 Mflops = 291.66 -Solve time = 0.00 -Solve flops = 1.654000e+04 Mflops = 433.59 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0203436; expected ratio = 0.0001obtained abs = 0.000590624; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0746574; expected ratio = 0.001obtained abs = 20.8408; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.485810e+05 Mflops = 289.59 -Solve time = 0.00 -Solve flops = 1.659200e+04 Mflops = 448.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00256752; expected ratio = 0.0001obtained abs = 7.44612e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00759783; expected ratio = 0.001obtained abs = 2.1336; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.00051713 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.482170e+05 Mflops = 298.30 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 448.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000620565; expected ratio = 0.0001obtained abs = 1.7997e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000915452; expected ratio = 0.001obtained abs = 0.257146; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.482170e+05 Mflops = 298.30 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 448.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000185602; expected ratio = 0.0001obtained abs = 5.38254e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000246037; expected ratio = 0.001obtained abs = 0.0691181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000802994 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.482170e+05 Mflops = 298.16 -Solve time = 0.00 -Solve flops = 1.656600e+04 Mflops = 448.28 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 8.9128e-05; expected ratio = 0.0001obtained abs = 2.58473e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103494; expected ratio = 0.001obtained abs = 0.0290754; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -writing a 2D mesh -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -step finished -0.001 -******** CURRENT TIME = 4.93181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.7624 - Final Residual ratio : 0.0103075 - Residual ratio : 0.000807644 - Slope : -0.398504 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.93281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.5074 - Final Residual ratio : 0.00984756 - Residual ratio : 0.000937203 - Slope : -0.361984 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.93381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.53842 - Final Residual ratio : 0.00556627 - Residual ratio : 0.000651909 - Slope : -0.284428 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.93481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.28926 - Final Residual ratio : 0.00593969 - Residual ratio : 0.000814856 - Slope : -0.242777 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.93581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.45696 - Final Residual ratio : 0.00557733 - Residual ratio : 0.000863771 - Slope : -0.215046 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.93681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.85038 - Final Residual ratio : 0.0049204 - Residual ratio : 0.000841039 - Slope : -0.201568 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.93781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.23595 - Final Residual ratio : 0.00399053 - Residual ratio : 0.000762141 - Slope : -0.174399 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.93881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.48107 - Final Residual ratio : 0.00714745 - Residual ratio : 0.000842753 - Slope : -0.273352 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.93981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.4175 - Final Residual ratio : 0.046558 - Residual ratio : 0.000942135 - Slope : -1.6457 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.93982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.94081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.3254 - Final Residual ratio : 0.0316686 - Residual ratio : 0.000642035 - Slope : -1.59012 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.94082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 5 - - Mesh 0 : - Number of Nodes : 120 - Number of Properties : 2 - Number of Elements : 138 - Number of Conditions : 38 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 120 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 120 - - Mesh vertices: 120 - Mesh triangles: 183 - Mesh edges: 302 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 183 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 120 - Input triangles: 138 - - Mesh vertices: 120 - Mesh triangles: 138 - Mesh edges: 226 - Mesh exterior boundary edges: 38 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 38 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.94082 -matrix_partition : [5](0,54,108,162,219) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.471160e+05 Mflops = 290.24 -Solve time = 0.00 -Solve flops = 1.650400e+04 Mflops = 443.74 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0186023; expected ratio = 0.0001obtained abs = 0.000544057; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0568594; expected ratio = 0.001obtained abs = 16.2515; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.491080e+05 Mflops = 296.40 -Solve time = 0.00 -Solve flops = 1.663600e+04 Mflops = 462.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00482278; expected ratio = 0.0001obtained abs = 0.00014091; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00802557; expected ratio = 0.001obtained abs = 2.3087; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000507116 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.489520e+05 Mflops = 294.97 -Solve time = 0.00 -Solve flops = 1.662400e+04 Mflops = 461.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000917083; expected ratio = 0.0001obtained abs = 2.6789e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00174827; expected ratio = 0.001obtained abs = 0.503274; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.481600e+05 Mflops = 293.96 -Solve time = 0.00 -Solve flops = 1.657600e+04 Mflops = 460.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000291749; expected ratio = 0.0001obtained abs = 8.52175e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00073259; expected ratio = 0.001obtained abs = 0.210964; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.480040e+05 Mflops = 292.96 -Solve time = 0.00 -Solve flops = 1.656400e+04 Mflops = 448.22 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000195258; expected ratio = 0.0001obtained abs = 5.70311e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000263963; expected ratio = 0.001obtained abs = 0.0760232; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000511169 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.480040e+05 Mflops = 285.68 -Solve time = 0.00 -Solve flops = 1.656400e+04 Mflops = 460.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.85317e-05; expected ratio = 0.0001obtained abs = 2.8779e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000169794; expected ratio = 0.001obtained abs = 0.0489055; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.94181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 44.7198 - Final Residual ratio : 0.0396394 - Residual ratio : 0.000886395 - Slope : -1.78721 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.94281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.2566 - Final Residual ratio : 0.060492 - Residual ratio : 0.000873448 - Slope : -2.56282 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.94381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 55.8351 - Final Residual ratio : 0.0444167 - Residual ratio : 0.000795498 - Slope : -1.92382 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.94481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.8759 - Final Residual ratio : 0.0295515 - Residual ratio : 0.000722957 - Slope : -1.36155 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.94581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.315 - Final Residual ratio : 0.0220032 - Residual ratio : 0.000750578 - Slope : -0.976434 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.94681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.6499 - Final Residual ratio : 0.0190988 - Residual ratio : 0.000924883 - Slope : -0.764105 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.94781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.8828 - Final Residual ratio : 0.0145167 - Residual ratio : 0.000975404 - Slope : -0.571855 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.94881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.8317 - Final Residual ratio : 0.0107144 - Residual ratio : 0.000905568 - Slope : -0.437815 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.94981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3808 - Final Residual ratio : 0.00918761 - Residual ratio : 0.000885062 - Slope : -0.384132 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.94982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.95081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.4777 - Final Residual ratio : 0.0454663 - Residual ratio : 0.00097824 - Slope : -2.73131 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.95082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 6 - - Mesh 0 : - Number of Nodes : 120 - Number of Properties : 2 - Number of Elements : 138 - Number of Conditions : 38 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0.01 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 120 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 120 - - Mesh vertices: 120 - Mesh triangles: 183 - Mesh edges: 302 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 183 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 120 - Input triangles: 138 - - Mesh vertices: 120 - Mesh triangles: 138 - Mesh edges: 226 - Mesh exterior boundary edges: 38 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 38 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.95082 -matrix_partition : [5](0,54,108,162,219) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 299.09 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 460.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.017997; expected ratio = 0.0001obtained abs = 0.000529171; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0626052; expected ratio = 0.001obtained abs = 17.3783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.94 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00194843; expected ratio = 0.0001obtained abs = 5.72553e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00739467; expected ratio = 0.001obtained abs = 2.06501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.37 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00105298; expected ratio = 0.0001obtained abs = 3.09369e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00103087; expected ratio = 0.001obtained abs = 0.287985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000505209 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.80 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 460.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000678563; expected ratio = 0.0001obtained abs = 1.99362e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000829836; expected ratio = 0.001obtained abs = 0.231902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.80 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000665396; expected ratio = 0.0001obtained abs = 1.95483e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000417395; expected ratio = 0.001obtained abs = 0.116642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000500917 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 299.66 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000559193; expected ratio = 0.0001obtained abs = 1.64285e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000490852; expected ratio = 0.001obtained abs = 0.137191; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.23 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000552706; expected ratio = 0.0001obtained abs = 1.62374e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000382686; expected ratio = 0.001obtained abs = 0.106952; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 301.51 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 460.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000499785; expected ratio = 0.0001obtained abs = 1.4683e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000406453; expected ratio = 0.001obtained abs = 0.113607; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000501871 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.23 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000492702; expected ratio = 0.0001obtained abs = 1.44745e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000356808; expected ratio = 0.001obtained abs = 0.0997234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.80 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000461974; expected ratio = 0.0001obtained abs = 1.35721e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000364504; expected ratio = 0.001obtained abs = 0.101883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000501871 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.23 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000454711; expected ratio = 0.0001obtained abs = 1.33584e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000336392; expected ratio = 0.001obtained abs = 0.0940191; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.80 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 460.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000434672; expected ratio = 0.0001obtained abs = 1.277e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000337797; expected ratio = 0.001obtained abs = 0.0944195; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.94 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000427465; expected ratio = 0.0001obtained abs = 1.25579e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000319884; expected ratio = 0.001obtained abs = 0.0894062; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.80 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 460.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000413026; expected ratio = 0.0001obtained abs = 1.2134e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000318345; expected ratio = 0.001obtained abs = 0.0889828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.23 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000406028; expected ratio = 0.0001obtained abs = 1.19282e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000305793; expected ratio = 0.001obtained abs = 0.0854685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000501871 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.80 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 476.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000394731; expected ratio = 0.0001obtained abs = 1.15965e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000302855; expected ratio = 0.001obtained abs = 0.0846532; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 314.69 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 486.25 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000388033; expected ratio = 0.0001obtained abs = 1.13995e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000293301; expected ratio = 0.001obtained abs = 0.0819771; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.94 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 460.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000378623; expected ratio = 0.0001obtained abs = 1.11233e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000289747; expected ratio = 0.001obtained abs = 0.0809893; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.23 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000372265; expected ratio = 0.0001obtained abs = 1.09363e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000281967; expected ratio = 0.001obtained abs = 0.0788096; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,138) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 219 -RHS size in solver: 219 -Factor time = 0.00 -Factor flops = 1.510330e+05 Mflops = 300.37 -Solve time = 0.00 -Solve flops = 1.657800e+04 Mflops = 473.01 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000364075; expected ratio = 0.0001obtained abs = 1.06959e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000278201; expected ratio = 0.001obtained abs = 0.0777622; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.95181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.4249 - Final Residual ratio : 0.036147 - Residual ratio : 0.000852023 - Slope : -1.51388 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.95281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.5288 - Final Residual ratio : 0.032521 - Residual ratio : 0.00096994 - Slope : -2.23309 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.95381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.53994 - Final Residual ratio : 0.00940014 - Residual ratio : 0.000985346 - Slope : -0.317685 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.95481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.8935 - Final Residual ratio : 0.00879031 - Residual ratio : 0.000806935 - Slope : -0.375333 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.95581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.6214 - Final Residual ratio : 0.0133152 - Residual ratio : 0.000910665 - Slope : -0.859297 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.95681962002 -kdt construction time 0.01 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.7906 - Final Residual ratio : 0.0200296 - Residual ratio : 0.000747637 - Slope : -0.923123 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.95781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.7988 - Final Residual ratio : 0.0295886 - Residual ratio : 0.000992946 - Slope : -0.960298 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.95881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.6719 - Final Residual ratio : 0.017018 - Residual ratio : 0.000865094 - Slope : -0.727957 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.95981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.91967 - Final Residual ratio : 0.00642886 - Residual ratio : 0.000720751 - Slope : -0.287524 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.95982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.96081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.92831 - Final Residual ratio : 0.00752546 - Residual ratio : 0.000757979 - Slope : -0.320025 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.96082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 120 - Number of Properties : 2 - Number of Elements : 138 - Number of Conditions : 38 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 120 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 120 - - Mesh vertices: 120 - Mesh triangles: 183 - Mesh edges: 302 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 183 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 120 - Input triangles: 139 - - Mesh vertices: 120 - Mesh triangles: 139 - Mesh edges: 228 - Mesh exterior boundary edges: 39 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 39 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.96082 -matrix_partition : [5](0,55,110,165,220) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.522760e+05 Mflops = 299.29 -Solve time = 0.00 -Solve flops = 1.675600e+04 Mflops = 465.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0182276; expected ratio = 0.0001obtained abs = 0.000538644; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.107676; expected ratio = 0.001obtained abs = 30.256; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.00052619 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.522760e+05 Mflops = 295.69 -Solve time = 0.00 -Solve flops = 1.675600e+04 Mflops = 465.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00234054; expected ratio = 0.0001obtained abs = 6.91133e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105833; expected ratio = 0.001obtained abs = 2.99341; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.522760e+05 Mflops = 300.28 -Solve time = 0.00 -Solve flops = 1.675600e+04 Mflops = 465.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000720838; expected ratio = 0.0001obtained abs = 2.1282e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00212907; expected ratio = 0.001obtained abs = 0.602539; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000516891 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 299.56 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000597642; expected ratio = 0.0001obtained abs = 1.76447e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00072285; expected ratio = 0.001obtained abs = 0.204629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 299.56 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000668548; expected ratio = 0.0001obtained abs = 1.97372e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000477782; expected ratio = 0.001obtained abs = 0.135246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 300.27 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 477.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000717593; expected ratio = 0.0001obtained abs = 2.11858e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000566825; expected ratio = 0.001obtained abs = 0.160475; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000517845 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 300.27 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 480.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000802947; expected ratio = 0.0001obtained abs = 2.37048e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00060374; expected ratio = 0.001obtained abs = 0.170904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000517845 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 299.56 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000887177; expected ratio = 0.0001obtained abs = 2.61926e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000675625; expected ratio = 0.001obtained abs = 0.191282; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 294.44 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000974047; expected ratio = 0.0001obtained abs = 2.87559e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000748855; expected ratio = 0.001obtained abs = 0.211979; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 300.27 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00107507; expected ratio = 0.0001obtained abs = 3.174e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000809185; expected ratio = 0.001obtained abs = 0.229096; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 299.00 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00115319; expected ratio = 0.0001obtained abs = 3.40445e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000894176; expected ratio = 0.001obtained abs = 0.253107; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 299.70 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00125006; expected ratio = 0.0001obtained abs = 3.69069e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000938765; expected ratio = 0.001obtained abs = 0.265781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000516176 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 299.70 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 477.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0013088; expected ratio = 0.0001obtained abs = 3.86385e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00101572; expected ratio = 0.001obtained abs = 0.287501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 299.70 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00138458; expected ratio = 0.0001obtained abs = 4.08788e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00104243; expected ratio = 0.001obtained abs = 0.295125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 300.12 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00142034; expected ratio = 0.0001obtained abs = 4.19315e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00109874; expected ratio = 0.001obtained abs = 0.310991; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000517845 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 294.98 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00146909; expected ratio = 0.0001obtained abs = 4.33742e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0011107; expected ratio = 0.001obtained abs = 0.31445; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 299.56 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 480.62 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00148608; expected ratio = 0.0001obtained abs = 4.38722e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114461; expected ratio = 0.001obtained abs = 0.323966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000516891 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 300.27 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 477.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00151182; expected ratio = 0.0001obtained abs = 4.46357e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114747; expected ratio = 0.001obtained abs = 0.324855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000516176 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 299.56 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 477.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00151724; expected ratio = 0.0001obtained abs = 4.47923e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00116428; expected ratio = 0.001obtained abs = 0.32953; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,34,68,102,139) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 220 -RHS size in solver: 220 -Factor time = 0.00 -Factor flops = 1.519120e+05 Mflops = 300.12 -Solve time = 0.00 -Solve flops = 1.673000e+04 Mflops = 464.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00152786; expected ratio = 0.0001obtained abs = 4.51095e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00116295; expected ratio = 0.001obtained abs = 0.329235; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.96181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.43857 - Final Residual ratio : 0.00645673 - Residual ratio : 0.000684079 - Slope : -0.304262 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.96281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.21403 - Final Residual ratio : 0.00795849 - Residual ratio : 0.00096889 - Slope : -0.328243 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.96381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.00531 - Final Residual ratio : 0.00679588 - Residual ratio : 0.000970104 - Slope : -0.233284 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.96481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.22122 - Final Residual ratio : 0.0048581 - Residual ratio : 0.000780892 - Slope : -0.214357 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.96581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.72533 - Final Residual ratio : 0.00524835 - Residual ratio : 0.00091669 - Slope : -0.190669 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.96681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.4181 - Final Residual ratio : 0.0051535 - Residual ratio : 0.000951164 - Slope : -0.193319 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.96781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.99471 - Final Residual ratio : 0.00470335 - Residual ratio : 0.000941667 - Slope : -0.160968 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.96881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.56697 - Final Residual ratio : 0.00410306 - Residual ratio : 0.00089842 - Slope : -0.147189 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.96981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.21965 - Final Residual ratio : 0.00405133 - Residual ratio : 0.000960112 - Slope : -0.131737 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.96982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.97081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.90266 - Final Residual ratio : 0.00376626 - Residual ratio : 0.000965048 - Slope : -0.12184 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.97082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 120 - Number of Properties : 2 - Number of Elements : 139 - Number of Conditions : 39 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 120 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 120 - - Mesh vertices: 120 - Mesh triangles: 183 - Mesh edges: 302 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 183 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 120 - Input triangles: 141 - - Mesh vertices: 122 - Mesh triangles: 145 - Mesh edges: 238 - Mesh exterior boundary edges: 41 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 41 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 2 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.97082 -matrix_partition : [5](0,57,114,171,228) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000538111 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.498400e+05 Mflops = 296.17 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 454.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.164503; expected ratio = 0.0001obtained abs = 0.00477745; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.820517; expected ratio = 0.001obtained abs = 457.118; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000536919 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.497660e+05 Mflops = 293.12 -Solve time = 0.00 -Solve flops = 1.690200e+04 Mflops = 457.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0775386; expected ratio = 0.0001obtained abs = 0.00220571; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.302929; expected ratio = 0.001obtained abs = 229.89; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.493500e+05 Mflops = 296.46 -Solve time = 0.00 -Solve flops = 1.687800e+04 Mflops = 453.79 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0322106; expected ratio = 0.0001obtained abs = 0.000907858; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.117376; expected ratio = 0.001obtained abs = 99.201; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.491380e+05 Mflops = 298.87 -Solve time = 0.00 -Solve flops = 1.686800e+04 Mflops = 456.45 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0143063; expected ratio = 0.0001obtained abs = 0.000401218; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0540953; expected ratio = 0.001obtained abs = 47.9248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.489260e+05 Mflops = 300.31 -Solve time = 0.00 -Solve flops = 1.685600e+04 Mflops = 468.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0077125; expected ratio = 0.0001obtained abs = 0.000215601; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0271135; expected ratio = 0.001obtained abs = 24.5922; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000516176 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.488380e+05 Mflops = 298.27 -Solve time = 0.00 -Solve flops = 1.684800e+04 Mflops = 467.98 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00488653; expected ratio = 0.0001obtained abs = 0.000136316; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0151161; expected ratio = 0.001obtained abs = 13.8875; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.484180e+05 Mflops = 299.28 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 467.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00353061; expected ratio = 0.0001obtained abs = 9.83424e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0090977; expected ratio = 0.001obtained abs = 8.42111; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.483960e+05 Mflops = 297.38 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 467.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00263829; expected ratio = 0.0001obtained abs = 7.34141e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00581112; expected ratio = 0.001obtained abs = 5.4033; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000528812 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.483960e+05 Mflops = 299.82 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 455.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00198089; expected ratio = 0.0001obtained abs = 5.50809e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00361217; expected ratio = 0.001obtained abs = 3.36774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.483960e+05 Mflops = 293.87 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 467.15 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00147499; expected ratio = 0.0001obtained abs = 4.09953e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0024598; expected ratio = 0.001obtained abs = 2.29723; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.483960e+05 Mflops = 299.67 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 455.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00110375; expected ratio = 0.0001obtained abs = 3.06665e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00151386; expected ratio = 0.001obtained abs = 1.41524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000521183 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.483960e+05 Mflops = 297.95 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 455.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000802488; expected ratio = 0.0001obtained abs = 2.22919e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00111017; expected ratio = 0.001obtained abs = 1.03854; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000516891 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.483960e+05 Mflops = 300.39 -Solve time = 0.00 -Solve flops = 1.681800e+04 Mflops = 455.10 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000602766; expected ratio = 0.0001obtained abs = 1.67412e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000656579; expected ratio = 0.001obtained abs = 0.614458; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.486340e+05 Mflops = 297.86 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 467.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000430449; expected ratio = 0.0001obtained abs = 1.19542e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000527135; expected ratio = 0.001obtained abs = 0.493453; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.486340e+05 Mflops = 300.88 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 455.47 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000326426; expected ratio = 0.0001obtained abs = 9.06467e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000292383; expected ratio = 0.001obtained abs = 0.273743; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.486340e+05 Mflops = 297.86 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 467.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000231009; expected ratio = 0.0001obtained abs = 6.41473e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000260598; expected ratio = 0.001obtained abs = 0.244013; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.486340e+05 Mflops = 300.30 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 467.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000177297; expected ratio = 0.0001obtained abs = 4.92307e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000133206; expected ratio = 0.001obtained abs = 0.124736; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.486340e+05 Mflops = 299.00 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 467.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000125482; expected ratio = 0.0001obtained abs = 3.48424e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000133037; expected ratio = 0.001obtained abs = 0.124584; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -Factor time = 0.00 -Factor flops = 1.486340e+05 Mflops = 300.30 -Solve time = 0.00 -Solve flops = 1.683200e+04 Mflops = 467.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 9.74472e-05; expected ratio = 0.0001obtained abs = 2.70575e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.22624e-05; expected ratio = 0.001obtained abs = 0.0583075; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.97181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.28598 - Final Residual ratio : 0.00764413 - Residual ratio : 0.00082319 - Slope : -0.299301 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.97281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.7022 - Final Residual ratio : 0.0237453 - Residual ratio : 0.000684258 - Slope : -1.15595 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.97381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.5802 - Final Residual ratio : 0.0329183 - Residual ratio : 0.000980288 - Slope : -1.11824 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.97481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.0719 - Final Residual ratio : 0.0166485 - Residual ratio : 0.000691613 - Slope : -0.801843 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.97581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.35045 - Final Residual ratio : 0.00740535 - Residual ratio : 0.000791978 - Slope : -0.29197 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.97681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.3526 - Final Residual ratio : 0.0167958 - Residual ratio : 0.000867884 - Slope : -0.623735 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.97781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.5452 - Final Residual ratio : 0.0182331 - Residual ratio : 0.00098317 - Slope : -0.617567 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.97881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.0879 - Final Residual ratio : 0.00991918 - Residual ratio : 0.000519657 - Slope : -0.635934 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.97981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.058 - Final Residual ratio : 0.0177152 - Residual ratio : 0.00092954 - Slope : -0.680012 - Tolerance : 0.001 - Number of iterations : 28 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.97982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.98081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.2005 - Final Residual ratio : 0.0186464 - Residual ratio : 0.000839909 - Slope : -0.715543 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.98082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 19 - - Mesh 0 : - Number of Nodes : 122 - Number of Properties : 2 - Number of Elements : 145 - Number of Conditions : 41 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 122 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 122 - - Mesh vertices: 122 - Mesh triangles: 187 - Mesh edges: 308 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 187 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 122 - Input triangles: 145 - - Mesh vertices: 122 - Mesh triangles: 145 - Mesh edges: 239 - Mesh exterior boundary edges: 43 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 43 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.98082 -matrix_partition : [5](0,57,114,171,229) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.490930e+05 Mflops = 294.00 -Solve time = 0.00 -Solve flops = 1.690600e+04 Mflops = 457.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.137748; expected ratio = 0.0001obtained abs = 0.00366647; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.02033; expected ratio = 0.001obtained abs = 1054.39; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000522137 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.514270e+05 Mflops = 297.49 -Solve time = 0.00 -Solve flops = 1.704800e+04 Mflops = 473.54 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0725976; expected ratio = 0.0001obtained abs = 0.00196776; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.214469; expected ratio = 0.001obtained abs = 74.4641; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.508550e+05 Mflops = 290.11 -Solve time = 0.00 -Solve flops = 1.701200e+04 Mflops = 460.35 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0250171; expected ratio = 0.0001obtained abs = 0.000681783; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0748956; expected ratio = 0.001obtained abs = 26.2838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.00052309 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.507270e+05 Mflops = 296.67 -Solve time = 0.00 -Solve flops = 1.700200e+04 Mflops = 460.07 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00426193; expected ratio = 0.0001obtained abs = 0.000116299; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0118502; expected ratio = 0.001obtained abs = 4.15117; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000521898 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.507790e+05 Mflops = 294.56 -Solve time = 0.00 -Solve flops = 1.701000e+04 Mflops = 460.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0012822; expected ratio = 0.0001obtained abs = 3.5002e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00350071; expected ratio = 0.001obtained abs = 1.22573; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000527143 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.507790e+05 Mflops = 298.59 -Solve time = 0.00 -Solve flops = 1.701000e+04 Mflops = 460.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00076669; expected ratio = 0.0001obtained abs = 2.09304e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000972062; expected ratio = 0.001obtained abs = 0.340302; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.507790e+05 Mflops = 298.59 -Solve time = 0.00 -Solve flops = 1.701000e+04 Mflops = 460.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000574566; expected ratio = 0.0001obtained abs = 1.56862e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00320206; expected ratio = 0.001obtained abs = 1.12152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.517170e+05 Mflops = 299.74 -Solve time = 0.00 -Solve flops = 1.706800e+04 Mflops = 461.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000685811; expected ratio = 0.0001obtained abs = 1.87221e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00125402; expected ratio = 0.001obtained abs = 0.439222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.517170e+05 Mflops = 300.45 -Solve time = 0.00 -Solve flops = 1.706800e+04 Mflops = 461.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000659726; expected ratio = 0.0001obtained abs = 1.80102e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00359613; expected ratio = 0.001obtained abs = 1.26035; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.517170e+05 Mflops = 299.88 -Solve time = 0.00 -Solve flops = 1.706800e+04 Mflops = 461.86 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000829695; expected ratio = 0.0001obtained abs = 2.26483e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00205817; expected ratio = 0.001obtained abs = 0.721257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.503310e+05 Mflops = 297.14 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 471.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000864339; expected ratio = 0.0001obtained abs = 2.35946e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00422142; expected ratio = 0.001obtained abs = 1.48044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.512690e+05 Mflops = 299.42 -Solve time = 0.00 -Solve flops = 1.703600e+04 Mflops = 473.21 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00104006; expected ratio = 0.0001obtained abs = 2.83884e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00319461; expected ratio = 0.001obtained abs = 1.11999; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.503310e+05 Mflops = 297.70 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 459.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00110005; expected ratio = 0.0001obtained abs = 3.00275e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00495648; expected ratio = 0.001obtained abs = 1.73914; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.503310e+05 Mflops = 297.56 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 459.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00123343; expected ratio = 0.0001obtained abs = 3.36645e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00429676; expected ratio = 0.001obtained abs = 1.50688; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000518799 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.503310e+05 Mflops = 297.14 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 459.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00127081; expected ratio = 0.0001obtained abs = 3.46873e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00550698; expected ratio = 0.001obtained abs = 1.93305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000529051 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.503310e+05 Mflops = 297.00 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 471.60 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00134254; expected ratio = 0.0001obtained abs = 3.66411e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00499058; expected ratio = 0.001obtained abs = 1.75064; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.503310e+05 Mflops = 297.70 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 459.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00134373; expected ratio = 0.0001obtained abs = 3.66765e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00575066; expected ratio = 0.001obtained abs = 2.01913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000521898 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.503310e+05 Mflops = 297.00 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 459.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00137388; expected ratio = 0.0001obtained abs = 3.74952e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00528094; expected ratio = 0.001obtained abs = 1.85285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.503310e+05 Mflops = 297.70 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 456.48 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00135361; expected ratio = 0.0001obtained abs = 3.6945e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00578115; expected ratio = 0.001obtained abs = 2.03021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,145) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.503310e+05 Mflops = 297.70 -Solve time = 0.00 -Solve flops = 1.697800e+04 Mflops = 459.43 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0013666; expected ratio = 0.0001obtained abs = 3.72958e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00535813; expected ratio = 0.001obtained abs = 1.88022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.98181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.6631 - Final Residual ratio : 0.0150873 - Residual ratio : 0.000696451 - Slope : -0.698322 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.98281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.76662 - Final Residual ratio : 0.0067021 - Residual ratio : 0.000990466 - Slope : -0.22533 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.98381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.2656 - Final Residual ratio : 0.0215468 - Residual ratio : 0.000887959 - Slope : -0.897926 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.98481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.8616 - Final Residual ratio : 0.0195743 - Residual ratio : 0.000985534 - Slope : -0.793681 - Tolerance : 0.001 - Number of iterations : 25 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.98581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.3206 - Final Residual ratio : 0.019152 - Residual ratio : 0.000942492 - Slope : -0.751904 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.98681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.4306 - Final Residual ratio : 0.0196473 - Residual ratio : 0.000804207 - Slope : -0.762842 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.98781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.5849 - Final Residual ratio : 0.0167866 - Residual ratio : 0.000954602 - Slope : -0.675696 - Tolerance : 0.001 - Number of iterations : 26 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.98881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.1481 - Final Residual ratio : 0.0118629 - Residual ratio : 0.000653672 - Slope : -0.58504 - Tolerance : 0.001 - Number of iterations : 31 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.98981962002 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.1067 - Final Residual ratio : 0.019944 - Residual ratio : 0.000991907 - Slope : -0.669559 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.98982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.99081962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.782 - Final Residual ratio : 0.00235195 - Residual ratio : 0.000621881 - Slope : -0.125988 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 4.99082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 122 - Number of Properties : 2 - Number of Elements : 145 - Number of Conditions : 43 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 121 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 121 - - Mesh vertices: 121 - Mesh triangles: 185 - Mesh edges: 305 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 185 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 121 - Input triangles: 144 - - Mesh vertices: 121 - Mesh triangles: 144 - Mesh edges: 237 - Mesh exterior boundary edges: 42 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 42 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 4.99082 -matrix_partition : [5](0,56,112,168,226) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.506250e+05 Mflops = 299.42 -Solve time = 0.00 -Solve flops = 1.689000e+04 Mflops = 454.11 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0829662; expected ratio = 0.0001obtained abs = 0.00224688; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.939685; expected ratio = 0.001obtained abs = 294.707; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.506080e+05 Mflops = 300.66 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 468.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0235215; expected ratio = 0.0001obtained abs = 0.000631374; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0462525; expected ratio = 0.001obtained abs = 14.8708; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.506080e+05 Mflops = 300.66 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 456.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00431072; expected ratio = 0.0001obtained abs = 0.000115566; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0264544; expected ratio = 0.001obtained abs = 8.60047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.506080e+05 Mflops = 301.24 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 468.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00256465; expected ratio = 0.0001obtained abs = 6.86976e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0143329; expected ratio = 0.001obtained abs = 4.68555; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.506080e+05 Mflops = 300.66 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 456.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00232865; expected ratio = 0.0001obtained abs = 6.23514e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.012851; expected ratio = 0.001obtained abs = 4.2197; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.506080e+05 Mflops = 296.43 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 468.76 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00214098; expected ratio = 0.0001obtained abs = 5.73028e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00995652; expected ratio = 0.001obtained abs = 3.27486; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 299.62 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 468.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00218137; expected ratio = 0.0001obtained abs = 5.83775e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105257; expected ratio = 0.001obtained abs = 3.47021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.506080e+05 Mflops = 301.24 -Solve time = 0.00 -Solve flops = 1.687600e+04 Mflops = 456.66 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00211159; expected ratio = 0.0001obtained abs = 5.6496e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00962136; expected ratio = 0.001obtained abs = 3.17307; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 300.62 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 456.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00210192; expected ratio = 0.0001obtained abs = 5.62377e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00967481; expected ratio = 0.001obtained abs = 3.19514; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 300.05 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 468.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00205418; expected ratio = 0.0001obtained abs = 5.49514e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00931408; expected ratio = 0.001obtained abs = 3.07523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 300.19 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 456.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00202922; expected ratio = 0.0001obtained abs = 5.42868e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00919004; expected ratio = 0.001obtained abs = 3.03719; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 300.05 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 468.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00199916; expected ratio = 0.0001obtained abs = 5.34758e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00901493; expected ratio = 0.001obtained abs = 2.97787; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 299.62 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 468.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00197731; expected ratio = 0.0001obtained abs = 5.28957e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00889867; expected ratio = 0.001obtained abs = 2.94174; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 300.19 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 468.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00196072; expected ratio = 0.0001obtained abs = 5.2446e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00880483; expected ratio = 0.001obtained abs = 2.90905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 300.19 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 468.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0019461; expected ratio = 0.0001obtained abs = 5.20595e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00873522; expected ratio = 0.001obtained abs = 2.88805; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000521898 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 300.76 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 456.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00193812; expected ratio = 0.0001obtained abs = 5.1841e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00868351; expected ratio = 0.001obtained abs = 2.86921; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 293.08 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 468.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00192957; expected ratio = 0.0001obtained abs = 5.16168e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00865149; expected ratio = 0.001obtained abs = 2.86052; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 299.05 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 468.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0019264; expected ratio = 0.0001obtained abs = 5.15271e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00862329; expected ratio = 0.001obtained abs = 2.84942; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 299.62 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 468.37 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00192174; expected ratio = 0.0001obtained abs = 5.14073e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00861261; expected ratio = 0.001obtained abs = 2.84774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,144) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -Factor time = 0.00 -Factor flops = 1.503700e+05 Mflops = 300.05 -Solve time = 0.00 -Solve flops = 1.686200e+04 Mflops = 456.29 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00192092; expected ratio = 0.0001obtained abs = 5.13803e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00859773; expected ratio = 0.001obtained abs = 2.84103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -0.001 -******** CURRENT TIME = 4.99181962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.0314 - Final Residual ratio : 0.0157376 - Residual ratio : 0.000826926 - Slope : -0.826768 - Tolerance : 0.001 - Number of iterations : 23 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99182 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.99281962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0.01 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.9206 - Final Residual ratio : 0.0150093 - Residual ratio : 0.000942763 - Slope : -0.530185 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99282 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.99381962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.3721 - Final Residual ratio : 0.0164791 - Residual ratio : 0.000948597 - Slope : -0.542363 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99382 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.99481962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2825 - Final Residual ratio : 0.0156014 - Residual ratio : 0.000958169 - Slope : -0.508342 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99482 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.99581962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.76 - Final Residual ratio : 0.0132207 - Residual ratio : 0.000895711 - Slope : -0.460837 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99582 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.99681962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.4494 - Final Residual ratio : 0.0197351 - Residual ratio : 0.000920077 - Slope : -0.714324 - Tolerance : 0.001 - Number of iterations : 30 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99682 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.99781962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.145 - Final Residual ratio : 0.0241596 - Residual ratio : 0.000728908 - Slope : -1.38003 - Tolerance : 0.001 - Number of iterations : 24 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99782 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.99881962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0.01 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.8081 - Final Residual ratio : 0.0184058 - Residual ratio : 0.000806986 - Slope : -0.844062 - Tolerance : 0.001 - Number of iterations : 27 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99882 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 4.99981962002 -kdt construction time 0 -search and interpolation time 0 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.7169 - Final Residual ratio : 0.0260994 - Residual ratio : 0.000941643 - Slope : -0.954855 - Tolerance : 0.001 - Number of iterations : 29 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 4.99982 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -step finished -0.001 -******** CURRENT TIME = 5.00081962002 -kdt construction time 0 -search and interpolation time 0.01 -kdt construction time 0 -search and interpolation time 0 -starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.6558 - Final Residual ratio : 0.00720004 - Residual ratio : 0.000675689 - Slope : -0.33277 - Tolerance : 0.001 - Number of iterations : 32 - Maximum number of iterations : 5000 -finished solving fluid edgebased -start checking the time stepping -0.001 -finished checking the time stepping -FixedFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - TIME : 5.00082 - DELTA_TIME : 0.001 - - Mesh 0 : - Number of Nodes : 691 - Number of Properties : 2 - Number of Elements : 1265 - Number of Conditions : 115 - -PfemFluidPart model part - Buffer Size : 2 - Current solution step index : 0 - DYNAMIC_TAU : 1 - OSS_SWITCH : 0 - TIME : 5.00082 - DELTA_TIME : 0.01 - NL_ITERATION_NUMBER : 20 - - Mesh 0 : - Number of Nodes : 121 - Number of Properties : 2 - Number of Elements : 144 - Number of Conditions : 42 - -starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -kdt construction time 0 -search and interpolation time 0 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 121 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 121 - - Mesh vertices: 121 - Mesh triangles: 185 - Mesh edges: 305 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 185 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 121 - Input triangles: 144 - - Mesh vertices: 122 - Mesh triangles: 146 - Mesh edges: 240 - Mesh exterior boundary edges: 42 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 42 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -Remesh in done! -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 5.00082 -matrix_partition : [5](0,57,114,171,229) -prediction -end of prediction -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.513420e+05 Mflops = 295.66 -Solve time = 0.00 -Solve flops = 1.701200e+04 Mflops = 457.39 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.061957; expected ratio = 0.0001obtained abs = 0.0016207; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.424; expected ratio = 0.001obtained abs = 127.566; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000533819 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0201289; expected ratio = 0.0001obtained abs = 0.000529092; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0808121; expected ratio = 0.001obtained abs = 25.1968; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000540018 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.509880e+05 Mflops = 295.93 -Solve time = 0.00 -Solve flops = 1.700400e+04 Mflops = 460.13 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00683343; expected ratio = 0.0001obtained abs = 0.000179297; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0440786; expected ratio = 0.001obtained abs = 14.0693; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 295.93 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.0031329; expected ratio = 0.0001obtained abs = 8.21267e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0216219; expected ratio = 0.001obtained abs = 6.97509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 297.04 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00190786; expected ratio = 0.0001obtained abs = 4.99909e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0139019; expected ratio = 0.001obtained abs = 4.51658; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00117545; expected ratio = 0.0001obtained abs = 3.07887e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00735289; expected ratio = 0.001obtained abs = 2.39797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 472.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000788745; expected ratio = 0.0001obtained abs = 2.06554e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00582334; expected ratio = 0.001obtained abs = 1.90444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000655345; expected ratio = 0.0001obtained abs = 1.7159e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00321249; expected ratio = 0.001obtained abs = 1.05228; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00048791; expected ratio = 0.0001obtained abs = 1.27736e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00303212; expected ratio = 0.001obtained abs = 0.994477; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000539064 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 355.12 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000444408; expected ratio = 0.0001obtained abs = 1.16335e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00189409; expected ratio = 0.001obtained abs = 0.621738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 295.93 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000355319; expected ratio = 0.0001obtained abs = 9.30073e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00187577; expected ratio = 0.001obtained abs = 0.616162; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 457.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000322621; expected ratio = 0.0001obtained abs = 8.44432e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00133818; expected ratio = 0.001obtained abs = 0.439795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00026867; expected ratio = 0.0001obtained abs = 7.03185e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00129223; expected ratio = 0.001obtained abs = 0.424886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 297.17 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 457.56 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000240812; expected ratio = 0.0001obtained abs = 6.30245e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00101064; expected ratio = 0.001obtained abs = 0.332419; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 295.79 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000205365; expected ratio = 0.0001obtained abs = 5.37457e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000944575; expected ratio = 0.001obtained abs = 0.310787; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.00018261; expected ratio = 0.0001obtained abs = 4.7789e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00078035; expected ratio = 0.001obtained abs = 0.256821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 289.58 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000157996; expected ratio = 0.0001obtained abs = 4.13464e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000712925; expected ratio = 0.001obtained abs = 0.234686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000537157 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 295.93 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 472.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000139981; expected ratio = 0.0001obtained abs = 3.6631e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000607646; expected ratio = 0.001obtained abs = 0.20007; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 296.48 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 472.71 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000122212; expected ratio = 0.0001obtained abs = 3.19806e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00054772; expected ratio = 0.001obtained abs = 0.180372; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 4 -element_partition : [5](0,36,72,108,146) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -Factor time = 0.00 -Factor flops = 1.511980e+05 Mflops = 293.05 -Solve time = 0.00 -Solve flops = 1.701800e+04 Mflops = 460.51 -Number of memory expansions: 0 -VELOCITY CRITERIA :: obtained ratio = 0.000108151; expected ratio = 0.0001obtained abs = 2.83004e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000475133; expected ratio = 0.001obtained abs = 0.156492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.001obtained abs = 0; expected abs = 1e-07 -*************************************************** -******* ATTENTION: max iterations exceeded ******** -*************************************************** -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -Solve in done! -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -finished solving structure -step finished -solution finished diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.init b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.init deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.lin b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.lin deleted file mode 100644 index 81ca36132da6..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.lin and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.mdpa b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.mdpa deleted file mode 100644 index 75c88152d788..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.mdpa +++ /dev/null @@ -1,833 +0,0 @@ -Begin ModelPartData -// VARIABLE_NAME value -End ModelPartData - -Begin Properties 0 -End Properties - - -Begin Nodes -1 2.50000e+00 2.00000e+00 0.00000e+00 -2 2.50000e+00 1.88235e+00 0.00000e+00 -3 2.50000e+00 1.76471e+00 0.00000e+00 -4 2.50000e+00 1.64706e+00 0.00000e+00 -5 2.50000e+00 1.52941e+00 0.00000e+00 -6 2.50000e+00 1.41176e+00 0.00000e+00 -7 2.50000e+00 1.29412e+00 0.00000e+00 -8 2.50000e+00 1.17647e+00 0.00000e+00 -9 2.50000e+00 1.05882e+00 0.00000e+00 -10 2.50000e+00 9.41176e-01 0.00000e+00 -11 2.50000e+00 8.23529e-01 0.00000e+00 -12 2.50000e+00 7.05882e-01 0.00000e+00 -13 2.50000e+00 5.88235e-01 0.00000e+00 -14 2.50000e+00 4.70588e-01 0.00000e+00 -15 2.50000e+00 3.52941e-01 0.00000e+00 -16 2.50000e+00 2.35294e-01 0.00000e+00 -17 2.50000e+00 1.17647e-01 0.00000e+00 -18 2.50000e+00 0.00000e+00 0.00000e+00 -19 2.38000e+00 0.00000e+00 0.00000e+00 -20 2.26000e+00 0.00000e+00 0.00000e+00 -21 2.14000e+00 0.00000e+00 0.00000e+00 -22 2.02000e+00 0.00000e+00 0.00000e+00 -23 1.90000e+00 0.00000e+00 0.00000e+00 -24 1.78000e+00 0.00000e+00 0.00000e+00 -25 1.66000e+00 0.00000e+00 0.00000e+00 -26 1.54000e+00 0.00000e+00 0.00000e+00 -27 8.83333e-01 4.16667e-01 0.00000e+00 -28 9.66667e-01 3.33333e-01 0.00000e+00 -29 8.00000e-01 5.00000e-01 0.00000e+00 -30 1.05000e+00 2.50000e-01 0.00000e+00 -31 1.42000e+00 0.00000e+00 0.00000e+00 -32 7.16667e-01 5.83333e-01 0.00000e+00 -33 1.13333e+00 1.66667e-01 0.00000e+00 -34 6.33333e-01 6.66667e-01 0.00000e+00 -35 1.21667e+00 8.33333e-02 0.00000e+00 -36 5.50000e-01 7.50000e-01 0.00000e+00 -37 1.30000e+00 0.00000e+00 0.00000e+00 -38 4.66667e-01 8.33333e-01 0.00000e+00 -39 8.52334e-01 3.15997e-01 0.00000e+00 -40 9.36344e-01 2.36532e-01 0.00000e+00 -41 7.68513e-01 3.96916e-01 0.00000e+00 -42 6.84867e-01 4.78817e-01 0.00000e+00 -43 1.10337e+00 8.17608e-02 0.00000e+00 -44 3.83333e-01 9.16667e-01 0.00000e+00 -45 1.01271e+00 1.42725e-01 0.00000e+00 -46 6.01344e-01 5.61325e-01 0.00000e+00 -47 1.18182e+00 0.00000e+00 0.00000e+00 -48 5.17899e-01 6.44193e-01 0.00000e+00 -49 3.00000e-01 1.00000e+00 0.00000e+00 -50 4.34503e-01 7.27268e-01 0.00000e+00 -51 8.39772e-01 2.05090e-01 0.00000e+00 -52 3.51134e-01 8.10459e-01 0.00000e+00 -53 1.06364e+00 0.00000e+00 0.00000e+00 -54 9.07769e-01 1.21388e-01 0.00000e+00 -55 6.53984e-01 3.63611e-01 0.00000e+00 -56 5.70071e-01 4.46139e-01 0.00000e+00 -57 7.34230e-01 2.47611e-01 0.00000e+00 -58 2.67781e-01 8.93714e-01 0.00000e+00 -59 4.86392e-01 5.29020e-01 0.00000e+00 -60 0.00000e+00 2.00000e+00 0.00000e+00 -61 0.00000e+00 1.87500e+00 0.00000e+00 -62 0.00000e+00 1.75000e+00 0.00000e+00 -63 4.02859e-01 6.12104e-01 0.00000e+00 -64 0.00000e+00 1.62500e+00 0.00000e+00 -65 9.45455e-01 0.00000e+00 0.00000e+00 -66 3.19412e-01 6.95300e-01 0.00000e+00 -67 0.00000e+00 1.50000e+00 0.00000e+00 -68 1.50000e-01 1.00000e+00 0.00000e+00 -69 6.23671e-01 2.48139e-01 0.00000e+00 -70 7.68182e-01 1.03923e-01 0.00000e+00 -71 2.36016e-01 7.78559e-01 0.00000e+00 -72 5.39157e-01 3.30781e-01 0.00000e+00 -73 0.00000e+00 1.37500e+00 0.00000e+00 -74 4.55099e-01 4.13744e-01 0.00000e+00 -75 3.71339e-01 4.96879e-01 0.00000e+00 -76 8.27273e-01 0.00000e+00 0.00000e+00 -77 0.00000e+00 1.25000e+00 0.00000e+00 -78 1.28960e-01 8.82640e-01 0.00000e+00 -79 2.87761e-01 5.80107e-01 0.00000e+00 -80 6.59650e-01 1.17266e-01 0.00000e+00 -81 0.00000e+00 1.12500e+00 0.00000e+00 -82 2.04290e-01 6.63384e-01 0.00000e+00 -83 5.06509e-01 2.24439e-01 0.00000e+00 -84 4.24127e-01 2.98298e-01 0.00000e+00 -85 7.09091e-01 0.00000e+00 0.00000e+00 -86 1.19961e-01 7.48570e-01 0.00000e+00 -87 0.00000e+00 1.00000e+00 0.00000e+00 -88 3.40010e-01 3.81552e-01 0.00000e+00 -89 2.56220e-01 4.64854e-01 0.00000e+00 -90 5.31818e-01 1.03923e-01 0.00000e+00 -91 0.00000e+00 8.75000e-01 0.00000e+00 -92 1.72627e-01 5.48175e-01 0.00000e+00 -93 5.90909e-01 0.00000e+00 0.00000e+00 -94 8.82509e-02 6.33320e-01 0.00000e+00 -95 3.08963e-01 2.66063e-01 0.00000e+00 -96 4.13770e-01 1.41052e-01 0.00000e+00 -97 0.00000e+00 7.50000e-01 0.00000e+00 -98 2.24846e-01 3.49504e-01 0.00000e+00 -99 1.41059e-01 4.32910e-01 0.00000e+00 -100 4.72727e-01 0.00000e+00 0.00000e+00 -101 0.00000e+00 6.25000e-01 0.00000e+00 -102 1.93717e-01 2.34003e-01 0.00000e+00 -103 2.80772e-01 1.24173e-01 0.00000e+00 -104 0.00000e+00 5.00000e-01 0.00000e+00 -105 1.09635e-01 3.17555e-01 0.00000e+00 -106 3.54545e-01 0.00000e+00 0.00000e+00 -107 0.00000e+00 3.75000e-01 0.00000e+00 -108 9.61249e-02 2.06096e-01 0.00000e+00 -109 2.36364e-01 0.00000e+00 0.00000e+00 -110 1.32166e-01 9.84675e-02 0.00000e+00 -111 0.00000e+00 2.50000e-01 0.00000e+00 -112 1.18182e-01 0.00000e+00 0.00000e+00 -113 0.00000e+00 1.25000e-01 0.00000e+00 -114 0.00000e+00 0.00000e+00 0.00000e+00 -End Nodes - -Begin Elements NoNewtonianASGS2D -1 0 37 35 43 -2 0 47 37 43 -3 0 43 35 33 -4 0 43 33 45 -5 0 45 33 30 -6 0 45 30 40 -7 0 43 45 65 -8 0 47 43 53 -9 0 53 43 65 -10 0 40 30 28 -11 0 40 28 39 -12 0 45 40 54 -13 0 40 39 51 -14 0 39 28 27 -15 0 39 27 41 -16 0 39 41 57 -17 0 41 27 29 -18 0 41 29 42 -19 0 41 42 55 -20 0 42 29 32 -21 0 42 32 46 -22 0 42 46 56 -23 0 46 32 34 -24 0 46 34 48 -25 0 48 34 36 -26 0 48 36 50 -27 0 46 48 59 -28 0 50 36 38 -29 0 50 38 52 -30 0 48 50 63 -31 0 52 38 44 -32 0 52 44 58 -33 0 50 52 66 -34 0 58 44 49 -35 0 58 49 68 -36 0 52 58 71 -37 0 100 93 90 -38 0 114 112 110 -39 0 85 76 70 -40 0 109 106 103 -41 0 93 85 80 -42 0 112 109 110 -43 0 106 100 96 -44 0 76 65 54 -45 0 54 40 51 -46 0 54 51 70 -47 0 70 51 57 -48 0 57 51 39 -49 0 45 54 65 -50 0 57 41 55 -51 0 57 55 69 -52 0 55 42 56 -53 0 55 56 72 -54 0 56 46 59 -55 0 56 59 74 -56 0 69 55 72 -57 0 69 72 83 -58 0 57 80 70 -59 0 59 48 63 -60 0 59 63 75 -61 0 72 56 74 -62 0 72 74 84 -63 0 63 50 66 -64 0 63 66 79 -65 0 71 58 78 -66 0 59 75 74 -67 0 74 75 88 -68 0 66 52 71 -69 0 66 71 82 -70 0 75 63 79 -71 0 75 79 89 -72 0 79 66 82 -73 0 79 82 92 -74 0 82 71 86 -75 0 92 82 94 -76 0 79 92 89 -77 0 89 92 99 -78 0 75 89 88 -79 0 88 89 98 -80 0 89 99 98 -81 0 98 99 105 -82 0 74 88 84 -83 0 84 88 95 -84 0 99 92 104 -85 0 72 84 83 -86 0 83 84 96 -87 0 88 98 95 -88 0 95 98 102 -89 0 110 109 103 -90 0 110 103 102 -91 0 90 93 80 -92 0 90 80 69 -93 0 103 106 96 -94 0 103 96 95 -95 0 96 100 90 -96 0 96 90 83 -97 0 83 90 69 -98 0 80 85 70 -99 0 80 57 69 -100 0 70 76 54 -101 0 105 99 107 -102 0 114 110 113 -103 0 98 105 102 -104 0 102 105 108 -105 0 84 95 96 -106 0 95 102 103 -107 0 108 105 111 -108 0 108 111 113 -109 0 108 113 110 -110 0 102 108 110 -111 0 71 78 86 -112 0 86 78 91 -113 0 78 58 68 -114 0 82 86 94 -115 0 94 86 97 -116 0 92 94 104 -117 0 97 86 91 -118 0 105 107 111 -119 0 97 101 94 -120 0 94 101 104 -121 0 104 107 99 -122 0 87 91 78 -123 0 78 68 87 -End Elements - - -Begin Conditions Condition2D -124 0 114 113 -125 0 113 111 -126 0 111 107 -127 0 107 104 -128 0 104 101 -129 0 101 97 -130 0 97 91 -131 0 91 87 -157 0 87 68 -158 0 68 49 -159 0 49 44 -160 0 44 38 -161 0 38 36 -162 0 36 34 -163 0 34 32 -164 0 32 29 -165 0 29 27 -166 0 27 28 -167 0 28 30 -168 0 30 33 -169 0 33 35 -170 0 35 37 -171 0 37 47 -172 0 47 53 -173 0 53 65 -174 0 65 76 -175 0 76 85 -176 0 85 93 -177 0 93 100 -178 0 100 106 -179 0 106 109 -180 0 109 112 -181 0 112 114 -End Conditions - - -Begin NodalData DISPLACEMENT_X -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -17 1 0.000000 -18 1 0.000000 -19 1 0.000000 -20 1 0.000000 -21 1 0.000000 -22 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -26 1 0.000000 -31 1 0.000000 -37 1 0.000000 -47 1 0.000000 -53 1 0.000000 -60 1 0.000000 -61 1 0.000000 -62 1 0.000000 -64 1 0.000000 -65 1 0.000000 -67 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -81 1 0.000000 -85 1 0.000000 -87 1 0.000000 -91 1 0.000000 -93 1 0.000000 -97 1 0.000000 -100 1 0.000000 -101 1 0.000000 -104 1 0.000000 -106 1 0.000000 -107 1 0.000000 -109 1 0.000000 -111 1 0.000000 -112 1 0.000000 -113 1 0.000000 -114 1 0.000000 -End NodalData - -Begin NodalData DISPLACEMENT_Y -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -17 1 0.000000 -18 1 0.000000 -19 1 0.000000 -20 1 0.000000 -21 1 0.000000 -22 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -26 1 0.000000 -31 1 0.000000 -37 1 0.000000 -47 1 0.000000 -53 1 0.000000 -60 1 0.000000 -61 1 0.000000 -62 1 0.000000 -64 1 0.000000 -65 1 0.000000 -67 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -81 1 0.000000 -85 1 0.000000 -87 1 0.000000 -91 1 0.000000 -93 1 0.000000 -97 1 0.000000 -100 1 0.000000 -101 1 0.000000 -104 1 0.000000 -106 1 0.000000 -107 1 0.000000 -109 1 0.000000 -111 1 0.000000 -112 1 0.000000 -113 1 0.000000 -114 1 0.000000 -End NodalData - -Begin NodalData DISPLACEMENT_Z -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -17 1 0.000000 -18 1 0.000000 -19 1 0.000000 -20 1 0.000000 -21 1 0.000000 -22 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -26 1 0.000000 -31 1 0.000000 -37 1 0.000000 -47 1 0.000000 -53 1 0.000000 -60 1 0.000000 -61 1 0.000000 -62 1 0.000000 -64 1 0.000000 -65 1 0.000000 -67 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -81 1 0.000000 -85 1 0.000000 -87 1 0.000000 -91 1 0.000000 -93 1 0.000000 -97 1 0.000000 -100 1 0.000000 -101 1 0.000000 -104 1 0.000000 -106 1 0.000000 -107 1 0.000000 -109 1 0.000000 -111 1 0.000000 -112 1 0.000000 -113 1 0.000000 -114 1 0.000000 -End NodalData - -Begin NodalData VELOCITY_X -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -17 1 0.000000 -18 1 0.000000 -19 1 0.000000 -20 1 0.000000 -21 1 0.000000 -22 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -26 1 0.000000 -31 1 0.000000 -37 1 0.000000 -47 1 0.000000 -53 1 0.000000 -60 1 0.000000 -61 1 0.000000 -62 1 0.000000 -64 1 0.000000 -65 1 0.000000 -67 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -81 1 0.000000 -85 1 0.000000 -87 1 0.000000 -91 1 0.000000 -93 1 0.000000 -97 1 0.000000 -100 1 0.000000 -101 1 0.000000 -104 1 0.000000 -106 1 0.000000 -107 1 0.000000 -109 1 0.000000 -111 1 0.000000 -112 1 0.000000 -113 1 0.000000 -114 1 0.000000 -End NodalData - -Begin NodalData VELOCITY_Y -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -17 1 0.000000 -18 1 0.000000 -19 1 0.000000 -20 1 0.000000 -21 1 0.000000 -22 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -26 1 0.000000 -31 1 0.000000 -37 1 0.000000 -47 1 0.000000 -53 1 0.000000 -60 1 0.000000 -61 1 0.000000 -62 1 0.000000 -64 1 0.000000 -65 1 0.000000 -67 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -81 1 0.000000 -85 1 0.000000 -87 1 0.000000 -91 1 0.000000 -93 1 0.000000 -97 1 0.000000 -100 1 0.000000 -101 1 0.000000 -104 1 0.000000 -106 1 0.000000 -107 1 0.000000 -109 1 0.000000 -111 1 0.000000 -112 1 0.000000 -113 1 0.000000 -114 1 0.000000 -End NodalData - -Begin NodalData VELOCITY_Z -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -17 1 0.000000 -18 1 0.000000 -19 1 0.000000 -20 1 0.000000 -21 1 0.000000 -22 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -26 1 0.000000 -31 1 0.000000 -37 1 0.000000 -47 1 0.000000 -53 1 0.000000 -60 1 0.000000 -61 1 0.000000 -62 1 0.000000 -64 1 0.000000 -65 1 0.000000 -67 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -81 1 0.000000 -85 1 0.000000 -87 1 0.000000 -91 1 0.000000 -93 1 0.000000 -97 1 0.000000 -100 1 0.000000 -101 1 0.000000 -104 1 0.000000 -106 1 0.000000 -107 1 0.000000 -109 1 0.000000 -111 1 0.000000 -112 1 0.000000 -113 1 0.000000 -114 1 0.000000 -End NodalData - -Begin NodalData INTERNAL_FRICTION_ANGLE -27 0 1.000000 -28 0 1.000000 -29 0 1.000000 -30 0 1.000000 -32 0 1.000000 -33 0 1.000000 -34 0 1.000000 -35 0 1.000000 -36 0 1.000000 -37 0 1.000000 -38 0 1.000000 -39 0 1.000000 -40 0 1.000000 -41 0 1.000000 -42 0 1.000000 -43 0 1.000000 -44 0 1.000000 -45 0 1.000000 -46 0 1.000000 -47 0 1.000000 -48 0 1.000000 -49 0 1.000000 -50 0 1.000000 -51 0 1.000000 -52 0 1.000000 -53 0 1.000000 -54 0 1.000000 -55 0 1.000000 -56 0 1.000000 -57 0 1.000000 -58 0 1.000000 -59 0 1.000000 -63 0 1.000000 -65 0 1.000000 -66 0 1.000000 -68 0 1.000000 -69 0 1.000000 -70 0 1.000000 -71 0 1.000000 -72 0 1.000000 -74 0 1.000000 -75 0 1.000000 -76 0 1.000000 -78 0 1.000000 -79 0 1.000000 -80 0 1.000000 -82 0 1.000000 -83 0 1.000000 -84 0 1.000000 -85 0 1.000000 -86 0 1.000000 -87 0 1.000000 -88 0 1.000000 -89 0 1.000000 -90 0 1.000000 -91 0 1.000000 -92 0 1.000000 -93 0 1.000000 -94 0 1.000000 -95 0 1.000000 -96 0 1.000000 -97 0 1.000000 -98 0 1.000000 -99 0 1.000000 -100 0 1.000000 -101 0 1.000000 -102 0 1.000000 -103 0 1.000000 -104 0 1.000000 -105 0 1.000000 -106 0 1.000000 -107 0 1.000000 -108 0 1.000000 -109 0 1.000000 -110 0 1.000000 -111 0 1.000000 -112 0 1.000000 -113 0 1.000000 -114 0 1.000000 -End NodalData - -Begin NodalData IS_BOUNDARY -27 1 1.000000 -28 1 1.000000 -29 1 1.000000 -30 1 1.000000 -32 1 1.000000 -33 1 1.000000 -34 1 1.000000 -35 1 1.000000 -36 1 1.000000 -37 1 1.000000 -38 1 1.000000 -44 1 1.000000 -47 1 1.000000 -49 1 1.000000 -53 1 1.000000 -65 1 1.000000 -68 1 1.000000 -76 1 1.000000 -85 1 1.000000 -87 1 1.000000 -91 1 1.000000 -93 1 1.000000 -97 1 1.000000 -100 1 1.000000 -101 1 1.000000 -104 1 1.000000 -106 1 1.000000 -107 1 1.000000 -109 1 1.000000 -111 1 1.000000 -112 1 1.000000 -113 1 1.000000 -114 1 1.000000 -End NodalData - -Begin NodalData IS_FREE_SURFACE -27 0 1.000000 -28 0 1.000000 -29 0 1.000000 -30 0 1.000000 -32 0 1.000000 -33 0 1.000000 -34 0 1.000000 -35 0 1.000000 -36 0 1.000000 -37 0 1.000000 -38 0 1.000000 -44 0 1.000000 -49 0 1.000000 -68 0 1.000000 -87 0 1.000000 -End NodalData - -Begin NodalData IS_STRUCTURE -1 0 1.000000 -2 0 1.000000 -3 0 1.000000 -4 0 1.000000 -5 0 1.000000 -6 0 1.000000 -7 0 1.000000 -8 0 1.000000 -9 0 1.000000 -10 0 1.000000 -11 0 1.000000 -12 0 1.000000 -13 0 1.000000 -14 0 1.000000 -15 0 1.000000 -16 0 1.000000 -17 0 1.000000 -18 0 1.000000 -19 0 1.000000 -20 0 1.000000 -21 0 1.000000 -22 0 1.000000 -23 0 1.000000 -24 0 1.000000 -25 0 1.000000 -26 0 1.000000 -31 0 1.000000 -37 0 1.000000 -47 0 1.000000 -53 0 1.000000 -60 0 1.000000 -61 0 1.000000 -62 0 1.000000 -64 0 1.000000 -65 0 1.000000 -67 0 1.000000 -73 0 1.000000 -76 0 1.000000 -77 0 1.000000 -81 0 1.000000 -85 0 1.000000 -87 0 1.000000 -91 0 1.000000 -93 0 1.000000 -97 0 1.000000 -100 0 1.000000 -101 0 1.000000 -104 0 1.000000 -106 0 1.000000 -107 0 1.000000 -109 0 1.000000 -111 0 1.000000 -112 0 1.000000 -113 0 1.000000 -114 0 1.000000 -End NodalData - - - diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.msh b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.msh deleted file mode 100644 index 6fcddbbd93e1..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.msh and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.node b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.node deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.png b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.png deleted file mode 100644 index cec9f7d3dd8d..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.png and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.prb b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.prb deleted file mode 100644 index 76660e5b34f2..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.prb +++ /dev/null @@ -1,68 +0,0 @@ -PROBLEM DATA -BOOK: Problem Parameters -QUESTION: Python_script_file#CB#(Use_Default,Do_not_write,Copy_From,Use_Current) -VALUE: Use_Default -DEPENDENCIES: (Use_Default,SET,Python_file,#CURRENT#)(Do_not_write,SET,Python_file,#CURRENT#)(Copy_From,RESTORE,Python_file,#CURRENT#)(Use_Current,SET,Python_file,#CURRENT#) -QUESTION: Python_file -VALUE: script.py -TKWIDGET: TkwidgetFilePath -QUESTION: Transfer_materials_to_lower_entities#CB#(1,0) -VALUE: 1 -QUESTION: Let_GiD_determine_domain_size#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (1,HIDE,DOMAIN_SIZE,#CURRENT#)(0,RESTORE,DOMAIN_SIZE,#CURRENT#) -QUESTION: DOMAIN_SIZE#CB#(2,3) -VALUE: 2 -STATE: HIDDEN -QUESTION: Density -VALUE: 1300.0 -QUESTION: Viscosity -VALUE: 0.0001 -QUESTION: Gravity_X -VALUE: 0.0 -QUESTION: Gravity_Y -VALUE: -9.806 -QUESTION: Gravity_Z -VALUE: 0.0 -QUESTION: Porosity -VALUE: 0.5 -QUESTION: Diameter -VALUE: 0.01 -QUESTION: YieldStress -VALUE: 3000.0 -QUESTION: max_x -VALUE: 2.5 -QUESTION: max_y -VALUE: 3.0 -QUESTION: max_z -VALUE: 1.0 -QUESTION: min_x -VALUE: -1.0 -QUESTION: min_y -VALUE: -1.0 -QUESTION: min_z -VALUE: -1.0 -QUESTION: use_oss -VALUE: 0 -QUESTION: dynamic_tau -VALUE: 1 -QUESTION: nsteps -VALUE: 10000 -QUESTION: output_dt -VALUE: 0.1 -QUESTION: min_dt -VALUE: 0.01 -QUESTION: max_dt -VALUE: 0.1 -QUESTION: safety_factor -VALUE: 0.1 -QUESTION: SolverType#CB#(pfem_solver_ale,monolithic_solver_lagrangian) -VALUE: monolithic_solver_lagrangian -QUESTION: laplacian_form -VALUE: 3 -QUESTION: fluid_file -VALUE: /home/antonia/kratos/applications/PFEMapplication/test_exemples/Coupled_slope2dNonNewt_fixed.gid/Coupled_slope2dNonNewt_fixed.mdpa -TKWIDGET: TkwidgetFilePath -END PROBLEM DATA -INTERVAL DATA -END INTERVAL DATA diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.prop b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.prop deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.rdr b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.rdr deleted file mode 100644 index ea11fa082101..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt.rdr and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_aux.unix.bat b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_aux.unix.bat deleted file mode 100755 index e84041e4d95c..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_aux.unix.bat +++ /dev/null @@ -1,25 +0,0 @@ -#!/bin/bash -i - -write_python_file="Use_Default" -file_location="script.py" -problemtype_name=pfem_nonewtonian_coupled - -mv $2/$1-3.dat $2/${problemtype_name}_var.py - -echo "problem_name=\"${1}\"" >> ${problemtype_name}_var.py -echo "problem_path=\"${2}\"" >> ${problemtype_name}_var.py -echo "kratos_path=\"${KRATOS_PATH}\"" >> ${problemtype_name}_var.py - -if [ $write_python_file = "Use_Default" ] -then - cp $3/script.py $2/ -# cp $3/run_example_trilinos.py $2/ -elif [ $write_python_file = "Copy_From" ] -then - cp $file_location $2/script.py -fi - -if [ -f script.py ] -then - python $2/script.py >& $2/$1.info -fi diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.cnd b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.cnd deleted file mode 100644 index f92e32f4042d..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.cnd +++ /dev/null @@ -1,713 +0,0 @@ -BOOK:Nodal Values -NUMBER: 1 CONDITION: point_VELOCITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 2 CONDITION: line_VELOCITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 3 CONDITION: surface_VELOCITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 4 CONDITION: volume_VELOCITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 5 CONDITION: point_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 6 CONDITION: line_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 7 CONDITION: surface_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 8 CONDITION: volume_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 9 CONDITION: point_DISTANCE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DISTANCE -VALUE: -1.0 -END CONDITION -NUMBER: 10 CONDITION: line_DISTANCE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DISTANCE -VALUE: -1.0 -END CONDITION -NUMBER: 11 CONDITION: surface_DISTANCE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DISTANCE -VALUE: -1.0 -END CONDITION -NUMBER: 12 CONDITION: volume_DISTANCE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DISTANCE -VALUE: -1.0 -END CONDITION -NUMBER: 13 CONDITION: point_POROSITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: POROSITY -VALUE: 1.0 -END CONDITION -NUMBER: 14 CONDITION: line_POROSITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: POROSITY -VALUE: 1.0 -END CONDITION -NUMBER: 15 CONDITION: surface_POROSITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: POROSITY -VALUE: 1.0 -END CONDITION -NUMBER: 16 CONDITION: volume_POROSITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: POROSITY -VALUE: 1.0 -END CONDITION -NUMBER: 17 CONDITION: point_DIAMETER -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DIAMETER -VALUE: 0.01 -END CONDITION -NUMBER: 18 CONDITION: line_DIAMETER -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DIAMETER -VALUE: 0.01 -END CONDITION -NUMBER: 19 CONDITION: surface_DIAMETER -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DIAMETER -VALUE: 0.01 -END CONDITION -NUMBER: 20 CONDITION: volume_DIAMETER -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: DIAMETER -VALUE: 0.01 -END CONDITION -BOOK:Elements -NUMBER: 21 CONDITION: surface_Fluid2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 22 CONDITION: volume_Fluid3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -BOOK:Conditions -NUMBER: 23 CONDITION: line_Condition2D -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 24 CONDITION: surface_Condition3D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -BOOK:Conditional Data -NUMBER: 25 CONDITION: line_IS_STRUCTURE -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(0.0,1.0) -VALUE: 0.0 -END CONDITION -NUMBER: 26 CONDITION: surface_IS_STRUCTURE -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(0.0,1.0) -VALUE: 0.0 -END CONDITION -BOOK:Model Parts -NUMBER: 27 CONDITION: point_FixedVelocity -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -END CONDITION -NUMBER: 28 CONDITION: line_FixedVelocity -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -END CONDITION -NUMBER: 29 CONDITION: surface_FixedVelocity -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -END CONDITION -NUMBER: 30 CONDITION: point_SlipCondition -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DIS_STRUCTURE -VALUE: BEGIN2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_STRUCTURE -VALUE: END2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: BEGIN3DIS_STRUCTURE -VALUE: BEGIN3DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END3DIS_STRUCTURE -VALUE: END3DIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 31 CONDITION: line_SlipCondition -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DIS_STRUCTURE -VALUE: BEGIN2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_STRUCTURE -VALUE: END2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: BEGIN3DIS_STRUCTURE -VALUE: BEGIN3DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END3DIS_STRUCTURE -VALUE: END3DIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 32 CONDITION: surface_SlipCondition -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DIS_STRUCTURE -VALUE: BEGIN2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_STRUCTURE -VALUE: END2DIS_STRUCTURE -STATE: HIDDEN -QUESTION: BEGIN3DIS_STRUCTURE -VALUE: BEGIN3DIS_STRUCTURE -STATE: HIDDEN -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: END3DIS_STRUCTURE -VALUE: END3DIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 33 CONDITION: point_FixedPressure -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINPRESSURE -VALUE: BEGINPRESSURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: PRESSURE -VALUE: 0.0 -QUESTION: ENDPRESSURE -VALUE: ENDPRESSURE -STATE: HIDDEN -END CONDITION -NUMBER: 34 CONDITION: line_FixedPressure -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINPRESSURE -VALUE: BEGINPRESSURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: PRESSURE -VALUE: 0.0 -QUESTION: ENDPRESSURE -VALUE: ENDPRESSURE -STATE: HIDDEN -END CONDITION -NUMBER: 35 CONDITION: surface_FixedPressure -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINPRESSURE -VALUE: BEGINPRESSURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: PRESSURE -VALUE: 0.0 -QUESTION: ENDPRESSURE -VALUE: ENDPRESSURE -STATE: HIDDEN -END CONDITION -BOOK:Default -NUMBER: 36 CONDITION: line_2D_Boundary_Condition -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: 2D_Boundary_Condition#CB#(Condition2D) -VALUE: Condition2D -END CONDITION -NUMBER: 37 CONDITION: surface_3D_Boundary_Condition -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: 3D_Boundary_Condition#CB#(Condition3D) -VALUE: Condition3D -END CONDITION -NUMBER: 38 CONDITION: surface_2D_Body_Element -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: 2D_Body_Element#CB#(Fluid2D) -VALUE: Fluid2D -END CONDITION -NUMBER: 39 CONDITION: volume_3D_Body_Element -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: 3D_Body_Element#CB#(Fluid3D) -VALUE: Fluid3D -END CONDITION -NUMBER: 40 CONDITION: point_Boundary -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Boundary_Condition -VALUE: BEGIN2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: 2D_Boundary_Condition#CB#(Condition2D) -VALUE: Use_Default -QUESTION: END2D2D_Boundary_Condition -VALUE: END2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: BEGIN3D3D_Boundary_Condition -VALUE: BEGIN3D3D_Boundary_Condition -STATE: HIDDEN -QUESTION: 3D_Boundary_Condition#CB#(Condition3D) -VALUE: Use_Default -QUESTION: END3D3D_Boundary_Condition -VALUE: END3D3D_Boundary_Condition -STATE: HIDDEN -END CONDITION -NUMBER: 41 CONDITION: line_Boundary -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Boundary_Condition -VALUE: BEGIN2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: 2D_Boundary_Condition#CB#(Condition2D) -VALUE: Use_Default -QUESTION: END2D2D_Boundary_Condition -VALUE: END2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: BEGIN3D3D_Boundary_Condition -VALUE: BEGIN3D3D_Boundary_Condition -STATE: HIDDEN -QUESTION: 3D_Boundary_Condition#CB#(Condition3D) -VALUE: Use_Default -QUESTION: END3D3D_Boundary_Condition -VALUE: END3D3D_Boundary_Condition -STATE: HIDDEN -END CONDITION -NUMBER: 42 CONDITION: surface_Boundary -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Boundary_Condition -VALUE: BEGIN2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: 2D_Boundary_Condition#CB#(Condition2D) -VALUE: Use_Default -QUESTION: END2D2D_Boundary_Condition -VALUE: END2D2D_Boundary_Condition -STATE: HIDDEN -QUESTION: BEGIN3D3D_Boundary_Condition -VALUE: BEGIN3D3D_Boundary_Condition -STATE: HIDDEN -QUESTION: 3D_Boundary_Condition#CB#(Condition3D) -VALUE: Use_Default -QUESTION: END3D3D_Boundary_Condition -VALUE: END3D3D_Boundary_Condition -STATE: HIDDEN -END CONDITION -NUMBER: 43 CONDITION: surface_Body -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Body_Element -VALUE: BEGIN2D2D_Body_Element -STATE: HIDDEN -QUESTION: 2D_Body_Element#CB#(Fluid2D) -VALUE: Use_Default -QUESTION: END2D2D_Body_Element -VALUE: END2D2D_Body_Element -STATE: HIDDEN -QUESTION: BEGIN3D3D_Body_Element -VALUE: BEGIN3D3D_Body_Element -STATE: HIDDEN -QUESTION: 3D_Body_Element#CB#(Fluid3D) -VALUE: Use_Default -QUESTION: END3D3D_Body_Element -VALUE: END3D3D_Body_Element -STATE: HIDDEN -END CONDITION -NUMBER: 44 CONDITION: volume_Body -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2D2D_Body_Element -VALUE: BEGIN2D2D_Body_Element -STATE: HIDDEN -QUESTION: 2D_Body_Element#CB#(Fluid2D) -VALUE: Use_Default -QUESTION: END2D2D_Body_Element -VALUE: END2D2D_Body_Element -STATE: HIDDEN -QUESTION: BEGIN3D3D_Body_Element -VALUE: BEGIN3D3D_Body_Element -STATE: HIDDEN -QUESTION: 3D_Body_Element#CB#(Fluid3D) -VALUE: Use_Default -QUESTION: END3D3D_Body_Element -VALUE: END3D3D_Body_Element -STATE: HIDDEN -END CONDITION diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.cond b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.cond deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.elem b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.elem deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.geo b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.geo deleted file mode 100644 index 23c01c3667dd..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.geo and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.info b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.info deleted file mode 100644 index 31648acdf38c..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.info +++ /dev/null @@ -1,26927 +0,0 @@ -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: False -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosMKLSolversApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -Import_FluidDynamicsApplication: False -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: True -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -Import_FluidDynamicsApplication: False -importing KratosIncompressibleFluidApplication ... -KratosIncompressibleFluidApplication lib loaded -KratosIncompressibleFluidApplication application created -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing KratosIncompressibleFluidApplication... -Initializing KratosIncompressibleFluidApplication...Register completed -Initializing KratosIncompressibleFluidApplication...variables succesfully registered -Initializing KratosIncompressibleFluidApplication...elements succesfully registered -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosIncompressibleFluidApplication Succesfully imported -variables for the edgebased incompressible fluid solver added correctly -Coupled_slope2dNonNewt_fixed opened for io -Coupled_slope2dNonNewt_fixed.node opened for io -Coupled_slope2dNonNewt_fixed.prop opened for io -Coupled_slope2dNonNewt_fixed.elem opened for io -Coupled_slope2dNonNewt_fixed.cond opened for io -Coupled_slope2dNonNewt_fixed.init opened for io -initializing result files - Reading Nodes : 691 nodes read - Reading Elements : 1265 Fluid2D read -lines read : 2287 -entered in EdgeBasedLevelSetSolver python constructor -entered in EdgeBasedLevelSetSolver initialize -entered in EdgeBasedLevelSetSolver python constructor -###################### max distance = 0.52846002091 -in 138 -nneg= 41 -npos= 650 -in 128 -nneg= 41 -npos= 650 -dimension in distance computation 2 -elements_to_solve.size() : 17 -********************************************** -finished EdgeBasedLevelSetSolver initialize -fluid solver created -1e-05 -******** CURRENT TIME = 1e-05 -1e-05 -******** CURRENT TIME = 2e-05 -1e-05 -******** CURRENT TIME = 3e-05 -1e-05 -******** CURRENT TIME = 4e-05 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 194.562 - Final Residual ratio : 0.0693415 - Residual ratio : 0.000356397 - Slope : -16.2077 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -1e-05 -1e-05 -******** CURRENT TIME = 5e-05 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 370.786 - Final Residual ratio : 0.266014 - Residual ratio : 0.000717433 - Slope : -30.8767 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -1e-05 -1e-05 -******** CURRENT TIME = 6e-05 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 422.034 - Final Residual ratio : 0.244267 - Residual ratio : 0.000578786 - Slope : -35.1491 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -1e-05 -1e-05 -******** CURRENT TIME = 7e-05 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 430.253 - Final Residual ratio : 0.227943 - Residual ratio : 0.000529788 - Slope : -43.0025 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -1e-05 -1e-05 -******** CURRENT TIME = 8e-05 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 434.548 - Final Residual ratio : 0.181896 - Residual ratio : 0.000418586 - Slope : -36.1971 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -1e-05 -1e-05 -******** CURRENT TIME = 9e-05 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 446.754 - Final Residual ratio : 0.110347 - Residual ratio : 0.000246998 - Slope : -37.2203 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -1e-05 -1e-05 -******** CURRENT TIME = 0.0001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 439.474 - Final Residual ratio : 0.165411 - Residual ratio : 0.000376384 - Slope : -36.6091 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -1e-05 -0.001 -******** CURRENT TIME = 0.0011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 309.004 - Final Residual ratio : 0.0285632 - Residual ratio : 9.24361e-05 - Slope : -25.748 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 193.722 - Final Residual ratio : 0.182863 - Residual ratio : 0.000943948 - Slope : -16.1283 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 456.316 - Final Residual ratio : 0.28562 - Residual ratio : 0.000625928 - Slope : -38.0025 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0041 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 789.451 - Final Residual ratio : 0.594601 - Residual ratio : 0.000753182 - Slope : -65.7381 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 972.583 - Final Residual ratio : 0.756942 - Residual ratio : 0.000778281 - Slope : -80.9855 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 946.743 - Final Residual ratio : 0.691527 - Residual ratio : 0.000730427 - Slope : -78.8376 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 823.106 - Final Residual ratio : 0.394766 - Residual ratio : 0.000479605 - Slope : -68.5593 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 682.771 - Final Residual ratio : 0.665033 - Residual ratio : 0.000974021 - Slope : -68.2106 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0091 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 548.26 - Final Residual ratio : 0.19051 - Residual ratio : 0.00034748 - Slope : -60.8967 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 505.801 - Final Residual ratio : 0.384586 - Residual ratio : 0.000760351 - Slope : -45.947 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 588.762 - Final Residual ratio : 0.299868 - Residual ratio : 0.000509319 - Slope : -45.2663 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 711.327 - Final Residual ratio : 0.593055 - Residual ratio : 0.000833729 - Slope : -59.2279 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 792.432 - Final Residual ratio : 0.448549 - Residual ratio : 0.000566041 - Slope : -65.9986 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0141 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 807.848 - Final Residual ratio : 0.375959 - Residual ratio : 0.000465383 - Slope : -67.2893 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 751.703 - Final Residual ratio : 0.419981 - Residual ratio : 0.000558706 - Slope : -62.6069 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 626.225 - Final Residual ratio : 0.501618 - Residual ratio : 0.000801018 - Slope : -56.8839 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 461.341 - Final Residual ratio : 0.369406 - Residual ratio : 0.000800722 - Slope : -38.4143 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 429.642 - Final Residual ratio : 0.356896 - Residual ratio : 0.000830681 - Slope : -39.0259 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0191 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 574.835 - Final Residual ratio : 0.415273 - Residual ratio : 0.000722421 - Slope : -52.22 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 697.021 - Final Residual ratio : 0.47168 - Residual ratio : 0.000676708 - Slope : -69.6549 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 707.749 - Final Residual ratio : 0.70351 - Residual ratio : 0.000994011 - Slope : -64.2768 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 659.457 - Final Residual ratio : 0.313904 - Residual ratio : 0.000476004 - Slope : -54.9286 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 604.601 - Final Residual ratio : 0.410193 - Residual ratio : 0.000678452 - Slope : -50.3492 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0241 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 530.911 - Final Residual ratio : 0.279529 - Residual ratio : 0.000526508 - Slope : -44.2193 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 449.489 - Final Residual ratio : 0.204948 - Residual ratio : 0.000455958 - Slope : -37.4404 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 451.901 - Final Residual ratio : 0.437551 - Residual ratio : 0.000968246 - Slope : -41.0421 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 504.71 - Final Residual ratio : 0.493573 - Residual ratio : 0.000977934 - Slope : -50.4216 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 555.757 - Final Residual ratio : 0.378669 - Residual ratio : 0.000681356 - Slope : -50.489 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0291 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 569.937 - Final Residual ratio : 0.531403 - Residual ratio : 0.000932388 - Slope : -71.1758 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 541.087 - Final Residual ratio : 0.451177 - Residual ratio : 0.000833834 - Slope : -60.0706 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 467.615 - Final Residual ratio : 0.21421 - Residual ratio : 0.000458091 - Slope : -51.9334 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 363.7 - Final Residual ratio : 0.298387 - Residual ratio : 0.000820422 - Slope : -36.3401 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 297.724 - Final Residual ratio : 0.119114 - Residual ratio : 0.000400082 - Slope : -24.8004 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0341 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 367.143 - Final Residual ratio : 0.3204 - Residual ratio : 0.000872685 - Slope : -33.3475 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 485.237 - Final Residual ratio : 0.413788 - Residual ratio : 0.000852754 - Slope : -40.402 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 552.558 - Final Residual ratio : 0.465264 - Residual ratio : 0.000842018 - Slope : -61.3437 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 552.321 - Final Residual ratio : 0.103031 - Residual ratio : 0.000186543 - Slope : -42.4783 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 542.33 - Final Residual ratio : 0.54104 - Residual ratio : 0.000997622 - Slope : -45.1491 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0391 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 499.877 - Final Residual ratio : 0.26464 - Residual ratio : 0.000529409 - Slope : -38.4317 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 415.1 - Final Residual ratio : 0.019431 - Residual ratio : 4.68105e-05 - Slope : -31.9293 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 459.847 - Final Residual ratio : 0.131709 - Residual ratio : 0.00028642 - Slope : -35.3627 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 463.217 - Final Residual ratio : 0.202262 - Residual ratio : 0.000436646 - Slope : -38.5845 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 542.579 - Final Residual ratio : 0.425654 - Residual ratio : 0.000784502 - Slope : -45.1794 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0441 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 573.886 - Final Residual ratio : 0.263546 - Residual ratio : 0.000459231 - Slope : -44.1248 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 544.132 - Final Residual ratio : 0.32109 - Residual ratio : 0.000590097 - Slope : -41.8316 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 456.849 - Final Residual ratio : 0.389452 - Residual ratio : 0.000852475 - Slope : -35.1122 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 339.147 - Final Residual ratio : 0.171304 - Residual ratio : 0.000505104 - Slope : -22.5984 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 349.14 - Final Residual ratio : 0.126184 - Residual ratio : 0.000361413 - Slope : -24.9295 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0491 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 327.298 - Final Residual ratio : 0.211843 - Residual ratio : 0.000647249 - Slope : -25.1605 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 392.649 - Final Residual ratio : 0.215449 - Residual ratio : 0.000548707 - Slope : -28.0309 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 495.063 - Final Residual ratio : 0.221685 - Residual ratio : 0.000447791 - Slope : -38.0647 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 517.033 - Final Residual ratio : 0.130209 - Residual ratio : 0.000251839 - Slope : -39.7617 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 464.193 - Final Residual ratio : 0.14097 - Residual ratio : 0.000303687 - Slope : -35.6963 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0541 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 378.483 - Final Residual ratio : 0.184658 - Residual ratio : 0.00048789 - Slope : -29.0999 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 305.484 - Final Residual ratio : 0.0808343 - Residual ratio : 0.00026461 - Slope : -23.4926 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 285.975 - Final Residual ratio : 0.0916996 - Residual ratio : 0.000320657 - Slope : -23.8236 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 327.431 - Final Residual ratio : 0.24877 - Residual ratio : 0.000759764 - Slope : -29.7438 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 384.681 - Final Residual ratio : 0.273457 - Residual ratio : 0.000710869 - Slope : -25.6271 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0591 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 423.631 - Final Residual ratio : 0.345034 - Residual ratio : 0.000814468 - Slope : -32.5605 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 426.593 - Final Residual ratio : 0.249836 - Residual ratio : 0.000585653 - Slope : -30.4531 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 390.615 - Final Residual ratio : 0.283462 - Residual ratio : 0.000725681 - Slope : -27.8808 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 323.007 - Final Residual ratio : 0.30121 - Residual ratio : 0.000932518 - Slope : -24.8235 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 247.734 - Final Residual ratio : 0.153739 - Residual ratio : 0.000620582 - Slope : -19.0446 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0641 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 215.998 - Final Residual ratio : 0.102518 - Residual ratio : 0.000474626 - Slope : -17.9913 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 264.703 - Final Residual ratio : 0.242273 - Residual ratio : 0.000915263 - Slope : -22.0384 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 332.519 - Final Residual ratio : 0.156279 - Residual ratio : 0.000469985 - Slope : -25.5663 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 395.79 - Final Residual ratio : 0.171308 - Residual ratio : 0.000432827 - Slope : -30.4322 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 383.653 - Final Residual ratio : 0.109192 - Residual ratio : 0.000284611 - Slope : -27.396 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0691 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 350.073 - Final Residual ratio : 0.227149 - Residual ratio : 0.000648863 - Slope : -26.9112 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 283.339 - Final Residual ratio : 0.126481 - Residual ratio : 0.000446394 - Slope : -20.2295 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 240.616 - Final Residual ratio : 0.0574884 - Residual ratio : 0.000238921 - Slope : -18.5045 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 255.454 - Final Residual ratio : 0.056262 - Residual ratio : 0.000220243 - Slope : -19.646 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 296.77 - Final Residual ratio : 0.183816 - Residual ratio : 0.00061939 - Slope : -22.8143 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0741 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 334.16 - Final Residual ratio : 0.236949 - Residual ratio : 0.000709089 - Slope : -25.6864 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 355.51 - Final Residual ratio : 0.32624 - Residual ratio : 0.000917668 - Slope : -27.3218 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 325.149 - Final Residual ratio : 0.183977 - Residual ratio : 0.000565825 - Slope : -24.9973 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 288.188 - Final Residual ratio : 0.0585066 - Residual ratio : 0.000203016 - Slope : -20.5807 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 221.74 - Final Residual ratio : 0.108502 - Residual ratio : 0.000489319 - Slope : -15.8308 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0791 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 180.151 - Final Residual ratio : 0.172431 - Residual ratio : 0.000957151 - Slope : -13.8445 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 193.8 - Final Residual ratio : 0.0846229 - Residual ratio : 0.000436651 - Slope : -14.9012 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 262.198 - Final Residual ratio : 0.0694058 - Residual ratio : 0.000264707 - Slope : -20.1637 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 287.987 - Final Residual ratio : 0.135728 - Residual ratio : 0.000471299 - Slope : -22.1424 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 314.464 - Final Residual ratio : 0.274177 - Residual ratio : 0.000871886 - Slope : -24.1685 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0841 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 284.985 - Final Residual ratio : 0.0789267 - Residual ratio : 0.000276951 - Slope : -20.3504 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 238.697 - Final Residual ratio : 0.169038 - Residual ratio : 0.00070817 - Slope : -19.8773 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 194.727 - Final Residual ratio : 0.0344949 - Residual ratio : 0.000177146 - Slope : -13.9066 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 181.535 - Final Residual ratio : 0.159817 - Residual ratio : 0.000880365 - Slope : -15.1146 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 200.547 - Final Residual ratio : 0.181726 - Residual ratio : 0.000906152 - Slope : -16.6971 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0891 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 229.399 - Final Residual ratio : 0.0737913 - Residual ratio : 0.000321672 - Slope : -17.6404 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 290.578 - Final Residual ratio : 0.210313 - Residual ratio : 0.000723774 - Slope : -22.336 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 281.076 - Final Residual ratio : 0.0816211 - Residual ratio : 0.000290388 - Slope : -20.071 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 249.589 - Final Residual ratio : 0.0617389 - Residual ratio : 0.000247362 - Slope : -17.8234 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 196.804 - Final Residual ratio : 0.138165 - Residual ratio : 0.000702043 - Slope : -17.8787 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0941 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 155.236 - Final Residual ratio : 0.153127 - Residual ratio : 0.000986412 - Slope : -11.9295 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 145.658 - Final Residual ratio : 0.0797444 - Residual ratio : 0.000547478 - Slope : -11.1983 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 168.984 - Final Residual ratio : 0.162319 - Residual ratio : 0.000960559 - Slope : -14.0685 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 221.944 - Final Residual ratio : 0.221189 - Residual ratio : 0.000996598 - Slope : -18.4769 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 231.516 - Final Residual ratio : 0.227466 - Residual ratio : 0.000982503 - Slope : -17.7915 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.0991 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 246.121 - Final Residual ratio : 0.0804126 - Residual ratio : 0.00032672 - Slope : -17.5743 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 213.117 - Final Residual ratio : 0.172635 - Residual ratio : 0.00081005 - Slope : -15.2103 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 174.063 - Final Residual ratio : 0.157344 - Residual ratio : 0.00090395 - Slope : -12.4218 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 148.575 - Final Residual ratio : 0.131309 - Residual ratio : 0.000883788 - Slope : -11.4188 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 150.15 - Final Residual ratio : 0.0340867 - Residual ratio : 0.000227018 - Slope : -11.5474 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1041 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 169.361 - Final Residual ratio : 0.0755423 - Residual ratio : 0.000446043 - Slope : -13.022 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 175.843 - Final Residual ratio : 0.127878 - Residual ratio : 0.000727229 - Slope : -13.5165 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 173.887 - Final Residual ratio : 0.115442 - Residual ratio : 0.000663887 - Slope : -13.3671 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 171.071 - Final Residual ratio : 0.156217 - Residual ratio : 0.00091317 - Slope : -13.1473 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 255.511 - Final Residual ratio : 0.0929346 - Residual ratio : 0.00036372 - Slope : -18.2442 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1091 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 152.663 - Final Residual ratio : 0.0993311 - Residual ratio : 0.000650655 - Slope : -10.8974 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 126.801 - Final Residual ratio : 0.0925651 - Residual ratio : 0.000730003 - Slope : -9.0506 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 128.699 - Final Residual ratio : 0.110839 - Residual ratio : 0.000861227 - Slope : -9.89143 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 165.926 - Final Residual ratio : 0.101994 - Residual ratio : 0.000614696 - Slope : -13.8187 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 199.048 - Final Residual ratio : 0.0828504 - Residual ratio : 0.000416233 - Slope : -15.305 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1141 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 208.596 - Final Residual ratio : 0.0908685 - Residual ratio : 0.000435619 - Slope : -14.8933 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 192.023 - Final Residual ratio : 0.133376 - Residual ratio : 0.000694586 - Slope : -13.7064 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 160.882 - Final Residual ratio : 0.151176 - Residual ratio : 0.000939671 - Slope : -12.3639 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 130.614 - Final Residual ratio : 0.0677067 - Residual ratio : 0.000518374 - Slope : -9.32472 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 121.675 - Final Residual ratio : 0.0523094 - Residual ratio : 0.00042991 - Slope : -8.68736 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1191 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 136.539 - Final Residual ratio : 0.0415964 - Residual ratio : 0.000304649 - Slope : -11.3748 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 155.079 - Final Residual ratio : 0.12343 - Residual ratio : 0.000795914 - Slope : -12.913 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 166.151 - Final Residual ratio : 0.0439573 - Residual ratio : 0.000264563 - Slope : -11.8648 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 164.557 - Final Residual ratio : 0.0642252 - Residual ratio : 0.000390291 - Slope : -11.7495 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 150.493 - Final Residual ratio : 0.0895092 - Residual ratio : 0.000594771 - Slope : -10.7431 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1241 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 128.986 - Final Residual ratio : 0.0475019 - Residual ratio : 0.000368271 - Slope : -8.59591 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 108.948 - Final Residual ratio : 0.0962921 - Residual ratio : 0.000883832 - Slope : -7.77515 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 101.775 - Final Residual ratio : 0.0384124 - Residual ratio : 0.000377424 - Slope : -7.26691 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 112.457 - Final Residual ratio : 0.10382 - Residual ratio : 0.0009232 - Slope : -9.36277 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 129.199 - Final Residual ratio : 0.105029 - Residual ratio : 0.000812923 - Slope : -10.7578 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1291 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 139.181 - Final Residual ratio : 0.123946 - Residual ratio : 0.000890534 - Slope : -10.6967 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 172.509 - Final Residual ratio : 0.0682909 - Residual ratio : 0.00039587 - Slope : -11.496 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 153.565 - Final Residual ratio : 0.0745749 - Residual ratio : 0.000485625 - Slope : -9.59314 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 107.872 - Final Residual ratio : 0.107363 - Residual ratio : 0.000995286 - Slope : -8.28956 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 107.065 - Final Residual ratio : 0.103626 - Residual ratio : 0.000967874 - Slope : -7.64012 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1341 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 126.263 - Final Residual ratio : 0.0834482 - Residual ratio : 0.000660909 - Slope : -9.7061 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 136.48 - Final Residual ratio : 0.0604148 - Residual ratio : 0.000442663 - Slope : -10.4938 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 194.541 - Final Residual ratio : 0.0798915 - Residual ratio : 0.000410668 - Slope : -14.9585 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 147.063 - Final Residual ratio : 0.0801206 - Residual ratio : 0.000544804 - Slope : -10.4988 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 143.273 - Final Residual ratio : 0.0444393 - Residual ratio : 0.000310171 - Slope : -9.5486 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1391 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 113.737 - Final Residual ratio : 0.0834544 - Residual ratio : 0.000733746 - Slope : -7.57693 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 92.0889 - Final Residual ratio : 0.0655203 - Residual ratio : 0.000711489 - Slope : -6.13489 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.9542 - Final Residual ratio : 0.0787037 - Residual ratio : 0.000905117 - Slope : -6.68273 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 98.0302 - Final Residual ratio : 0.0485464 - Residual ratio : 0.000495219 - Slope : -6.99869 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 111.698 - Final Residual ratio : 0.0972477 - Residual ratio : 0.000870627 - Slope : -8.58471 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1441 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 117.363 - Final Residual ratio : 0.0579549 - Residual ratio : 0.000493809 - Slope : -8.37893 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 112.591 - Final Residual ratio : 0.0724476 - Residual ratio : 0.000643461 - Slope : -8.03701 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 125.78 - Final Residual ratio : 0.0430805 - Residual ratio : 0.000342506 - Slope : -7.85857 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.8017 - Final Residual ratio : 0.0455388 - Residual ratio : 0.00052463 - Slope : -5.42226 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.007 - Final Residual ratio : 0.0245617 - Residual ratio : 0.000285578 - Slope : -6.1416 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1491 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 85.7153 - Final Residual ratio : 0.0359637 - Residual ratio : 0.000419572 - Slope : -6.59072 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 90.8977 - Final Residual ratio : 0.0352153 - Residual ratio : 0.000387416 - Slope : -6.49018 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 96.1295 - Final Residual ratio : 0.0621451 - Residual ratio : 0.000646473 - Slope : -7.3898 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 95.632 - Final Residual ratio : 0.0321926 - Residual ratio : 0.00033663 - Slope : -6.82856 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 89.379 - Final Residual ratio : 0.0803654 - Residual ratio : 0.000899154 - Slope : -6.37847 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1541 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 79.9488 - Final Residual ratio : 0.0792467 - Residual ratio : 0.000991218 - Slope : -5.32464 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.3363 - Final Residual ratio : 0.0295814 - Residual ratio : 0.000408943 - Slope : -4.82045 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.1183 - Final Residual ratio : 0.068349 - Residual ratio : 0.000947734 - Slope : -5.54231 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 78.2871 - Final Residual ratio : 0.0402687 - Residual ratio : 0.000514371 - Slope : -5.58906 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 84.6414 - Final Residual ratio : 0.0533751 - Residual ratio : 0.000630603 - Slope : -6.50677 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1591 -dimension in distance computation 2 -elements_to_solve.size() : 14 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.1768 - Final Residual ratio : 0.0579678 - Residual ratio : 0.000672662 - Slope : -6.62452 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 81.8467 - Final Residual ratio : 0.0581464 - Residual ratio : 0.00071043 - Slope : -5.84204 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 77.6741 - Final Residual ratio : 0.0420563 - Residual ratio : 0.000541446 - Slope : -4.852 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 80.1849 - Final Residual ratio : 0.0737794 - Residual ratio : 0.000920116 - Slope : -5.34074 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 95.1538 - Final Residual ratio : 0.0451911 - Residual ratio : 0.000474927 - Slope : -6.34057 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1641 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 79.6395 - Final Residual ratio : 0.040231 - Residual ratio : 0.000505164 - Slope : -5.68566 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 84.0435 - Final Residual ratio : 0.0662026 - Residual ratio : 0.000787719 - Slope : -5.99838 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 83.3427 - Final Residual ratio : 0.0749046 - Residual ratio : 0.000898755 - Slope : -5.9477 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 78.2509 - Final Residual ratio : 0.0374852 - Residual ratio : 0.000479039 - Slope : -5.21422 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 68.3632 - Final Residual ratio : 0.0605748 - Residual ratio : 0.000886073 - Slope : -4.55351 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1691 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 58.217 - Final Residual ratio : 0.0342484 - Residual ratio : 0.000588289 - Slope : -3.63642 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.7786 - Final Residual ratio : 0.0376013 - Residual ratio : 0.000686423 - Slope : -3.6494 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 59.446 - Final Residual ratio : 0.0503833 - Residual ratio : 0.000847547 - Slope : -4.24255 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.7937 - Final Residual ratio : 0.0465375 - Residual ratio : 0.000696734 - Slope : -4.76766 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 115.191 - Final Residual ratio : 0.0555603 - Residual ratio : 0.000482333 - Slope : -7.67567 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1741 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.4691 - Final Residual ratio : 0.0668302 - Residual ratio : 0.00099053 - Slope : -4.81445 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.4331 - Final Residual ratio : 0.020862 - Residual ratio : 0.000309374 - Slope : -4.49415 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 59.9748 - Final Residual ratio : 0.0297788 - Residual ratio : 0.000496521 - Slope : -3.99634 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 63.2123 - Final Residual ratio : 0.0227117 - Residual ratio : 0.000359293 - Slope : -5.2658 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.8814 - Final Residual ratio : 0.0465403 - Residual ratio : 0.000848015 - Slope : -4.21807 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1791 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 57.6224 - Final Residual ratio : 0.0416453 - Residual ratio : 0.000722727 - Slope : -4.11291 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 61.4694 - Final Residual ratio : 0.0378351 - Residual ratio : 0.000615511 - Slope : -4.38797 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 61.57 - Final Residual ratio : 0.0358564 - Residual ratio : 0.000582367 - Slope : -5.12784 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 57.0465 - Final Residual ratio : 0.0495082 - Residual ratio : 0.000867858 - Slope : -4.07121 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.6962 - Final Residual ratio : 0.0358636 - Residual ratio : 0.000721658 - Slope : -3.31069 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1841 -dimension in distance computation 2 -elements_to_solve.size() : 15 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.6539 - Final Residual ratio : 0.021949 - Residual ratio : 0.000502795 - Slope : -2.727 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.5205 - Final Residual ratio : 0.0320177 - Residual ratio : 0.000735693 - Slope : -3.10632 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.7982 - Final Residual ratio : 0.0307256 - Residual ratio : 0.000629647 - Slope : -3.48339 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.4153 - Final Residual ratio : 0.0284236 - Residual ratio : 0.000522346 - Slope : -3.88478 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 56.2838 - Final Residual ratio : 0.0498447 - Residual ratio : 0.000885596 - Slope : -4.32569 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1891 -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.7934 - Final Residual ratio : 0.0413329 - Residual ratio : 0.000628223 - Slope : -4.69657 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 45.5253 - Final Residual ratio : 0.0238872 - Residual ratio : 0.000524701 - Slope : -3.03343 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.6319 - Final Residual ratio : 0.0248226 - Residual ratio : 0.000596239 - Slope : -3.20055 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.39 - Final Residual ratio : 0.023816 - Residual ratio : 0.000604621 - Slope : -2.62441 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.0726 - Final Residual ratio : 0.0178475 - Residual ratio : 0.000414359 - Slope : -3.07534 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1941 -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 47.8611 - Final Residual ratio : 0.0114877 - Residual ratio : 0.000240022 - Slope : -3.18997 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.1639 - Final Residual ratio : 0.0248783 - Residual ratio : 0.000495941 - Slope : -3.58136 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.5033 - Final Residual ratio : 0.0276767 - Residual ratio : 0.000570616 - Slope : -3.72889 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 53.2821 - Final Residual ratio : 0.0519162 - Residual ratio : 0.000974364 - Slope : -3.54868 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 57.7399 - Final Residual ratio : 0.0504371 - Residual ratio : 0.000873523 - Slope : -4.12067 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.1991 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 48.9939 - Final Residual ratio : 0.0387227 - Residual ratio : 0.000790358 - Slope : -3.26368 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 225.417 - Final Residual ratio : 0.114727 - Residual ratio : 0.000508955 - Slope : -15.0201 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 117.713 - Final Residual ratio : 0.0353506 - Residual ratio : 0.000300313 - Slope : -7.84514 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 121.366 - Final Residual ratio : 0.119522 - Residual ratio : 0.000984813 - Slope : -9.32661 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 76.3398 - Final Residual ratio : 0.0426319 - Residual ratio : 0.000558449 - Slope : -4.76858 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2041 -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 70.566 - Final Residual ratio : 0.0642776 - Residual ratio : 0.000910886 - Slope : -4.70011 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.516 - Final Residual ratio : 0.0565076 - Residual ratio : 0.000790139 - Slope : -5.49688 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 47.9709 - Final Residual ratio : 0.0353721 - Residual ratio : 0.000737367 - Slope : -3.1957 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.0781 - Final Residual ratio : 0.0259211 - Residual ratio : 0.000663314 - Slope : -2.78944 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.3341 - Final Residual ratio : 0.00926826 - Residual ratio : 0.000241776 - Slope : -2.55499 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2091 -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.8148 - Final Residual ratio : 0.0305537 - Residual ratio : 0.000713625 - Slope : -2.85228 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.0193 - Final Residual ratio : 0.0258975 - Residual ratio : 0.000601998 - Slope : -2.86623 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.8984 - Final Residual ratio : 0.0371616 - Residual ratio : 0.00095535 - Slope : -2.59075 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.7175 - Final Residual ratio : 0.0195874 - Residual ratio : 0.000617558 - Slope : -1.98112 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.0055 - Final Residual ratio : 0.0112144 - Residual ratio : 0.000415263 - Slope : -1.68714 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2141 -dimension in distance computation 2 -elements_to_solve.size() : 16 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.1809 - Final Residual ratio : 0.0151933 - Residual ratio : 0.000503408 - Slope : -2.01105 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.2838 - Final Residual ratio : 0.0096429 - Residual ratio : 0.000245468 - Slope : -2.61828 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.7551 - Final Residual ratio : 0.0295482 - Residual ratio : 0.000631976 - Slope : -2.92035 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.5482 - Final Residual ratio : 0.0355162 - Residual ratio : 0.000651098 - Slope : -3.63418 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 45.9631 - Final Residual ratio : 0.0213986 - Residual ratio : 0.00046556 - Slope : -2.87135 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2191 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.23 - Final Residual ratio : 0.0426123 - Residual ratio : 0.000865576 - Slope : -3.07421 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.6736 - Final Residual ratio : 0.0241375 - Residual ratio : 0.000716807 - Slope : -2.10309 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.7319 - Final Residual ratio : 0.0155964 - Residual ratio : 0.000542825 - Slope : -1.79477 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.7175 - Final Residual ratio : 0.0156079 - Residual ratio : 0.000525209 - Slope : -1.98012 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.3954 - Final Residual ratio : 0.0194122 - Residual ratio : 0.000519107 - Slope : -2.336 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2241 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.1448 - Final Residual ratio : 0.0405016 - Residual ratio : 0.00096101 - Slope : -2.63152 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 41.227 - Final Residual ratio : 0.0208148 - Residual ratio : 0.000504882 - Slope : -2.57539 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.4371 - Final Residual ratio : 0.0255597 - Residual ratio : 0.000721269 - Slope : -2.21322 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.0413 - Final Residual ratio : 0.0157771 - Residual ratio : 0.000583446 - Slope : -1.68909 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.4751 - Final Residual ratio : 0.00401595 - Residual ratio : 0.000187005 - Slope : -1.34194 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2291 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.0678 - Final Residual ratio : 0.00922892 - Residual ratio : 0.000383455 - Slope : -1.60391 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.2472 - Final Residual ratio : 0.022487 - Residual ratio : 0.000719649 - Slope : -2.08165 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 36.6377 - Final Residual ratio : 0.034995 - Residual ratio : 0.000955165 - Slope : -2.28767 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.6975 - Final Residual ratio : 0.0307432 - Residual ratio : 0.000815524 - Slope : -2.51111 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.1785 - Final Residual ratio : 0.0316215 - Residual ratio : 0.000925185 - Slope : -2.13418 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2341 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.3456 - Final Residual ratio : 0.0219998 - Residual ratio : 0.000804512 - Slope : -1.95168 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.9354 - Final Residual ratio : 0.00457798 - Residual ratio : 0.000218672 - Slope : -1.30818 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.679 - Final Residual ratio : 0.0102494 - Residual ratio : 0.000520828 - Slope : -1.31125 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.9995 - Final Residual ratio : 0.0177169 - Residual ratio : 0.000738219 - Slope : -1.59878 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.7835 - Final Residual ratio : 0.0203264 - Residual ratio : 0.000706182 - Slope : -1.7977 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2391 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.8299 - Final Residual ratio : 0.0216622 - Residual ratio : 0.000702634 - Slope : -1.92552 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.0195 - Final Residual ratio : 0.022528 - Residual ratio : 0.000776304 - Slope : -1.81231 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.1526 - Final Residual ratio : 0.0219306 - Residual ratio : 0.000908003 - Slope : -1.50816 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.5459 - Final Residual ratio : 0.0121961 - Residual ratio : 0.000657617 - Slope : -1.09022 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5737 - Final Residual ratio : 0.00455692 - Residual ratio : 0.000274948 - Slope : -1.03557 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2441 -dimension in distance computation 2 -elements_to_solve.size() : 17 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.0241 - Final Residual ratio : 0.00701185 - Residual ratio : 0.000350171 - Slope : -1.33447 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.0487 - Final Residual ratio : 0.0136369 - Residual ratio : 0.000544415 - Slope : -1.56469 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.6866 - Final Residual ratio : 0.0222273 - Residual ratio : 0.000622849 - Slope : -2.37762 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.7789 - Final Residual ratio : 0.0251717 - Residual ratio : 0.000874658 - Slope : -2.05384 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.8504 - Final Residual ratio : 0.0248379 - Residual ratio : 0.000960833 - Slope : -1.6141 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2491 -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.4899 - Final Residual ratio : 0.0171164 - Residual ratio : 0.00087822 - Slope : -1.21705 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.2439 - Final Residual ratio : 0.00227742 - Residual ratio : 0.000149399 - Slope : -0.952603 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.0421 - Final Residual ratio : 0.00792096 - Residual ratio : 0.00049376 - Slope : -1.06895 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9199 - Final Residual ratio : 0.00787151 - Residual ratio : 0.000395159 - Slope : -1.2445 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.1371 - Final Residual ratio : 0.0154685 - Residual ratio : 0.000668558 - Slope : -1.44511 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2541 -dimension in distance computation 2 -elements_to_solve.size() : 18 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.0227 - Final Residual ratio : 0.0153718 - Residual ratio : 0.000639887 - Slope : -1.60049 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.917 - Final Residual ratio : 0.0201891 - Residual ratio : 0.000921162 - Slope : -1.36855 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.8719 - Final Residual ratio : 0.0166831 - Residual ratio : 0.000933482 - Slope : -1.19035 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.9833 - Final Residual ratio : 0.0150314 - Residual ratio : 0.000429673 - Slope : -2.18551 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.6652 - Final Residual ratio : 0.0134088 - Residual ratio : 0.000484681 - Slope : -1.72824 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2591 -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.0106 - Final Residual ratio : 0.0157053 - Residual ratio : 0.000603803 - Slope : -1.62468 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.6777 - Final Residual ratio : 0.0136747 - Residual ratio : 0.000694933 - Slope : -1.229 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.158 - Final Residual ratio : 0.0195432 - Residual ratio : 0.000969498 - Slope : -1.54911 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.148 - Final Residual ratio : 0.017719 - Residual ratio : 0.000925366 - Slope : -1.19564 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2895 - Final Residual ratio : 0.0154595 - Residual ratio : 0.000949045 - Slope : -1.01713 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2641 -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.7 - Final Residual ratio : 0.00634206 - Residual ratio : 0.000499373 - Slope : -0.746688 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.0646 - Final Residual ratio : 0.00372483 - Residual ratio : 0.000336643 - Slope : -0.691306 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.4119 - Final Residual ratio : 0.00396848 - Residual ratio : 0.00031973 - Slope : -0.827198 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.8787 - Final Residual ratio : 0.0147288 - Residual ratio : 0.000569147 - Slope : -1.6165 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.0018 - Final Residual ratio : 0.0286875 - Residual ratio : 0.000683007 - Slope : -2.79821 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2691 -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.3012 - Final Residual ratio : 0.0311948 - Residual ratio : 0.00062016 - Slope : -2.95706 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.7697 - Final Residual ratio : 0.0214629 - Residual ratio : 0.000985908 - Slope : -1.55344 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.6778 - Final Residual ratio : 0.00917803 - Residual ratio : 0.000723943 - Slope : -0.791791 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.0927 - Final Residual ratio : 0.00614393 - Residual ratio : 0.00055387 - Slope : -0.652152 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.9421 - Final Residual ratio : 0.0092183 - Residual ratio : 0.000771917 - Slope : -0.745804 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2741 -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.8738 - Final Residual ratio : 0.00909718 - Residual ratio : 0.000655712 - Slope : -0.866541 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 44.4515 - Final Residual ratio : 0.0385467 - Residual ratio : 0.000867164 - Slope : -2.96086 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.2124 - Final Residual ratio : 0.00901239 - Residual ratio : 0.000494848 - Slope : -1.30024 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.5034 - Final Residual ratio : 0.0127285 - Residual ratio : 0.0006879 - Slope : -1.23271 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.1689 - Final Residual ratio : 0.00974335 - Residual ratio : 0.000687658 - Slope : -0.832891 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2791 -dimension in distance computation 2 -elements_to_solve.size() : 19 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.7196 - Final Residual ratio : 0.00769685 - Residual ratio : 0.000718016 - Slope : -0.630112 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.32862 - Final Residual ratio : 0.0079715 - Residual ratio : 0.00095712 - Slope : -0.55471 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.65588 - Final Residual ratio : 0.0025137 - Residual ratio : 0.000290404 - Slope : -0.540835 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 40.6366 - Final Residual ratio : 0.0231032 - Residual ratio : 0.000568531 - Slope : -2.70757 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.7535 - Final Residual ratio : 0.0123819 - Residual ratio : 0.00078598 - Slope : -0.983818 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2841 -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.1238 - Final Residual ratio : 0.00380222 - Residual ratio : 0.000251406 - Slope : -0.945001 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.6549 - Final Residual ratio : 0.00738216 - Residual ratio : 0.000583344 - Slope : -0.903395 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.1865 - Final Residual ratio : 0.0111352 - Residual ratio : 0.00099542 - Slope : -0.745023 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.44594 - Final Residual ratio : 0.00505932 - Residual ratio : 0.000535608 - Slope : -0.555346 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.56967 - Final Residual ratio : 0.0028529 - Residual ratio : 0.000332907 - Slope : -0.50393 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2891 -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.24296 - Final Residual ratio : 0.00584708 - Residual ratio : 0.000632599 - Slope : -0.577319 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.9042 - Final Residual ratio : 0.00643006 - Residual ratio : 0.000589687 - Slope : -0.68111 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.096 - Final Residual ratio : 0.00806788 - Residual ratio : 0.000666987 - Slope : -0.755495 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.1338 - Final Residual ratio : 0.00684274 - Residual ratio : 0.000563941 - Slope : -0.866211 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.9488 - Final Residual ratio : 0.00640848 - Residual ratio : 0.000585314 - Slope : -0.683899 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2941 -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.98542 - Final Residual ratio : 0.00861532 - Residual ratio : 0.000958811 - Slope : -0.56105 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.15401 - Final Residual ratio : 0.00367389 - Residual ratio : 0.000513543 - Slope : -0.446896 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.84325 - Final Residual ratio : 0.00344547 - Residual ratio : 0.000503485 - Slope : -0.427488 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.8424 - Final Residual ratio : 0.0187191 - Residual ratio : 0.000898127 - Slope : -1.30148 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.9362 - Final Residual ratio : 0.0297699 - Residual ratio : 0.000903866 - Slope : -2.19377 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.2991 -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 39.7533 - Final Residual ratio : 0.0358861 - Residual ratio : 0.000902721 - Slope : -2.48234 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.5775 - Final Residual ratio : 0.0161362 - Residual ratio : 0.000868585 - Slope : -1.4278 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.9212 - Final Residual ratio : 0.00892145 - Residual ratio : 0.000899231 - Slope : -0.583075 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.0981 - Final Residual ratio : 0.00650928 - Residual ratio : 0.000803803 - Slope : -0.505725 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.37273 - Final Residual ratio : 0.00660469 - Residual ratio : 0.000895827 - Slope : -0.460383 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3041 -dimension in distance computation 2 -elements_to_solve.size() : 20 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.58245 - Final Residual ratio : 0.00312 - Residual ratio : 0.000411476 - Slope : -0.445843 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.76995 - Final Residual ratio : 0.0060137 - Residual ratio : 0.000685717 - Slope : -0.584263 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.72302 - Final Residual ratio : 0.00634736 - Residual ratio : 0.000652817 - Slope : -0.647778 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.6846 - Final Residual ratio : 0.0108421 - Residual ratio : 0.000353341 - Slope : -2.19098 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.4709 - Final Residual ratio : 0.00704491 - Residual ratio : 0.000672806 - Slope : -0.747421 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3091 -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.32651 - Final Residual ratio : 0.00509656 - Residual ratio : 0.00054646 - Slope : -0.665815 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.14098 - Final Residual ratio : 0.0033902 - Residual ratio : 0.000552061 - Slope : -0.383599 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.80658 - Final Residual ratio : 0.0032247 - Residual ratio : 0.000670892 - Slope : -0.30021 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.23794 - Final Residual ratio : 0.0031049 - Residual ratio : 0.000592772 - Slope : -0.327177 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.44435 - Final Residual ratio : 0.00514774 - Residual ratio : 0.0007988 - Slope : -0.40245 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3141 -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.42584 - Final Residual ratio : 0.00327956 - Residual ratio : 0.000441642 - Slope : -0.436621 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.38786 - Final Residual ratio : 0.0071258 - Residual ratio : 0.000964528 - Slope : -0.461296 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.58214 - Final Residual ratio : 0.00371985 - Residual ratio : 0.000565143 - Slope : -0.469887 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.26082 - Final Residual ratio : 0.0027088 - Residual ratio : 0.0005149 - Slope : -0.328632 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.20414 - Final Residual ratio : 0.00178488 - Residual ratio : 0.000424552 - Slope : -0.247197 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3191 -dimension in distance computation 2 -elements_to_solve.size() : 21 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.29906 - Final Residual ratio : 0.00364594 - Residual ratio : 0.000848077 - Slope : -0.268463 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.59645 - Final Residual ratio : 0.00393503 - Residual ratio : 0.000703129 - Slope : -0.349532 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.77446 - Final Residual ratio : 0.00624797 - Residual ratio : 0.000922284 - Slope : -0.423013 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.32479 - Final Residual ratio : 0.0072067 - Residual ratio : 0.000983878 - Slope : -0.457349 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.0635 - Final Residual ratio : 0.00614821 - Residual ratio : 0.00087042 - Slope : -0.504097 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3241 -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.3087 - Final Residual ratio : 0.0536866 - Residual ratio : 0.000822045 - Slope : -4.35033 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.8932 - Final Residual ratio : 0.0115549 - Residual ratio : 0.000645771 - Slope : -1.19211 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.7556 - Final Residual ratio : 0.00930763 - Residual ratio : 0.000791759 - Slope : -0.839023 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.63463 - Final Residual ratio : 0.00544301 - Residual ratio : 0.000820393 - Slope : -0.441946 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.52989 - Final Residual ratio : 0.00333723 - Residual ratio : 0.000443198 - Slope : -0.442738 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3291 -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.44493 - Final Residual ratio : 0.0064508 - Residual ratio : 0.000682991 - Slope : -0.555205 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.6084 - Final Residual ratio : 0.00714071 - Residual ratio : 0.000673119 - Slope : -0.623603 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.595 - Final Residual ratio : 0.00883997 - Residual ratio : 0.000834353 - Slope : -0.661635 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.47116 - Final Residual ratio : 0.00690772 - Residual ratio : 0.000729343 - Slope : -0.591516 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.58355 - Final Residual ratio : 0.00391684 - Residual ratio : 0.000516491 - Slope : -0.541403 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3341 -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.65971 - Final Residual ratio : 0.00285994 - Residual ratio : 0.000505315 - Slope : -0.377123 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.71231 - Final Residual ratio : 0.00439235 - Residual ratio : 0.000932101 - Slope : -0.294245 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.44383 - Final Residual ratio : 0.00307983 - Residual ratio : 0.000565747 - Slope : -0.340047 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.74192 - Final Residual ratio : 0.00588587 - Residual ratio : 0.000873026 - Slope : -0.421002 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.4463 - Final Residual ratio : 0.0115473 - Residual ratio : 0.000538429 - Slope : -1.42898 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3391 -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.9917 - Final Residual ratio : 0.030422 - Residual ratio : 0.00060854 - Slope : -3.56867 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.5924 - Final Residual ratio : 0.0206239 - Residual ratio : 0.000579448 - Slope : -2.54084 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2835 - Final Residual ratio : 0.0105047 - Residual ratio : 0.000645109 - Slope : -1.16236 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.12091 - Final Residual ratio : 0.00453853 - Residual ratio : 0.000558869 - Slope : -0.477434 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.95124 - Final Residual ratio : 0.00307012 - Residual ratio : 0.000441666 - Slope : -0.408716 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3441 -dimension in distance computation 2 -elements_to_solve.size() : 22 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.95889 - Final Residual ratio : 0.00677243 - Residual ratio : 0.000973204 - Slope : -0.434508 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.9108 - Final Residual ratio : 0.00472689 - Residual ratio : 0.000683986 - Slope : -0.40624 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.70324 - Final Residual ratio : 0.00514775 - Residual ratio : 0.000767949 - Slope : -0.394006 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.1929 - Final Residual ratio : 0.00596362 - Residual ratio : 0.000962977 - Slope : -0.386683 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.396 - Final Residual ratio : 0.0471534 - Residual ratio : 0.0009546 - Slope : -4.1124 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3491 -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.60327 - Final Residual ratio : 0.0058145 - Residual ratio : 0.000605471 - Slope : -0.63983 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.78645 - Final Residual ratio : 0.00770752 - Residual ratio : 0.000989863 - Slope : -0.555625 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.04715 - Final Residual ratio : 0.00410527 - Residual ratio : 0.000678876 - Slope : -0.431646 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.10608 - Final Residual ratio : 0.00606772 - Residual ratio : 0.000853876 - Slope : -0.546155 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.53409 - Final Residual ratio : 0.00496494 - Residual ratio : 0.000658996 - Slope : -0.579164 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3541 -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.15902 - Final Residual ratio : 0.00570381 - Residual ratio : 0.000796731 - Slope : -0.476888 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.04773 - Final Residual ratio : 0.00501652 - Residual ratio : 0.000829489 - Slope : -0.402847 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.77462 - Final Residual ratio : 0.00340896 - Residual ratio : 0.000713975 - Slope : -0.298201 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.77814 - Final Residual ratio : 0.00194567 - Residual ratio : 0.000514983 - Slope : -0.236012 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.47778 - Final Residual ratio : 0.00202713 - Residual ratio : 0.000582879 - Slope : -0.231717 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3591 -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.84716 - Final Residual ratio : 0.00343988 - Residual ratio : 0.000894134 - Slope : -0.240232 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.91995 - Final Residual ratio : 0.00254385 - Residual ratio : 0.00064895 - Slope : -0.244838 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.78758 - Final Residual ratio : 0.00372364 - Residual ratio : 0.000983117 - Slope : -0.252257 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.31577 - Final Residual ratio : 0.00246526 - Residual ratio : 0.000743497 - Slope : -0.220887 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.73698 - Final Residual ratio : 0.000618648 - Residual ratio : 0.000226033 - Slope : -0.171023 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3641 -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.60295 - Final Residual ratio : 0.00222916 - Residual ratio : 0.000856396 - Slope : -0.185766 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.82418 - Final Residual ratio : 0.00224029 - Residual ratio : 0.000793253 - Slope : -0.201567 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.40439 - Final Residual ratio : 0.00156679 - Residual ratio : 0.000460225 - Slope : -0.226855 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.81821 - Final Residual ratio : 0.0021286 - Residual ratio : 0.000557486 - Slope : -0.272577 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.8683 - Final Residual ratio : 0.0031414 - Residual ratio : 0.000812088 - Slope : -0.29732 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3691 -dimension in distance computation 2 -elements_to_solve.size() : 23 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.46128 - Final Residual ratio : 0.00208459 - Residual ratio : 0.000602258 - Slope : -0.230613 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.8638 - Final Residual ratio : 0.00149058 - Residual ratio : 0.000520492 - Slope : -0.178894 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.23925 - Final Residual ratio : 0.00168888 - Residual ratio : 0.000754217 - Slope : -0.139847 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00384 - Final Residual ratio : 0.0012152 - Residual ratio : 0.000606432 - Slope : -0.117802 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.30176 - Final Residual ratio : 0.00173081 - Residual ratio : 0.000751947 - Slope : -0.143752 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3741 -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.3572 - Final Residual ratio : 0.0234509 - Residual ratio : 0.000747864 - Slope : -2.41029 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.20061 - Final Residual ratio : 0.00342856 - Residual ratio : 0.000659261 - Slope : -0.371227 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.68866 - Final Residual ratio : 0.00385387 - Residual ratio : 0.00057618 - Slope : -0.477486 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.94836 - Final Residual ratio : 0.00221677 - Residual ratio : 0.000751865 - Slope : -0.184134 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.21675 - Final Residual ratio : 0.000342846 - Residual ratio : 0.000154662 - Slope : -0.130377 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3791 -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.88971 - Final Residual ratio : 0.00151273 - Residual ratio : 0.000800512 - Slope : -0.12588 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03371 - Final Residual ratio : 0.00138837 - Residual ratio : 0.000682682 - Slope : -0.135488 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.53355 - Final Residual ratio : 0.00236474 - Residual ratio : 0.000933367 - Slope : -0.168746 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.6483 - Final Residual ratio : 0.0121286 - Residual ratio : 0.000687236 - Slope : -1.10226 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.12 - Final Residual ratio : 0.0232716 - Residual ratio : 0.00077263 - Slope : -2.14976 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3841 -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.8823 - Final Residual ratio : 0.0290791 - Residual ratio : 0.000884337 - Slope : -2.34666 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.4377 - Final Residual ratio : 0.0131152 - Residual ratio : 0.000975997 - Slope : -0.958902 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.27667 - Final Residual ratio : 0.00528299 - Residual ratio : 0.000841686 - Slope : -0.447956 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.34676 - Final Residual ratio : 0.00422123 - Residual ratio : 0.000789492 - Slope : -0.314267 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.10073 - Final Residual ratio : 0.00440692 - Residual ratio : 0.000863977 - Slope : -0.339755 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3891 -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.94722 - Final Residual ratio : 0.00467162 - Residual ratio : 0.000944292 - Slope : -0.329503 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.51 - Final Residual ratio : 0.00322953 - Residual ratio : 0.000716081 - Slope : -0.281673 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.89894 - Final Residual ratio : 0.00336632 - Residual ratio : 0.000863395 - Slope : -0.259705 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.18473 - Final Residual ratio : 0.00158765 - Residual ratio : 0.000498521 - Slope : -0.21221 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.65578 - Final Residual ratio : 0.00139392 - Residual ratio : 0.000524861 - Slope : -0.176959 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3941 -dimension in distance computation 2 -elements_to_solve.size() : 24 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.5405 - Final Residual ratio : 0.00119822 - Residual ratio : 0.000471648 - Slope : -0.169287 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.0349 - Final Residual ratio : 0.00247296 - Residual ratio : 0.000814841 - Slope : -0.216602 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.52278 - Final Residual ratio : 0.00304337 - Residual ratio : 0.000863911 - Slope : -0.251409 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79347 - Final Residual ratio : 0.00362895 - Residual ratio : 0.000956633 - Slope : -0.270703 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 73.5535 - Final Residual ratio : 0.0684701 - Residual ratio : 0.000930889 - Slope : -5.24893 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.3991 -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.4715 - Final Residual ratio : 0.0111617 - Residual ratio : 0.000573229 - Slope : -1.21627 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.4368 - Final Residual ratio : 0.00675249 - Residual ratio : 0.000542942 - Slope : -0.887864 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.72827 - Final Residual ratio : 0.00449396 - Residual ratio : 0.000784524 - Slope : -0.357736 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.13953 - Final Residual ratio : 0.00310956 - Residual ratio : 0.000506482 - Slope : -0.360966 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.08972 - Final Residual ratio : 0.00581113 - Residual ratio : 0.000819657 - Slope : -0.47226 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4041 -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.62548 - Final Residual ratio : 0.00560737 - Residual ratio : 0.000735346 - Slope : -0.476242 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.58547 - Final Residual ratio : 0.00424232 - Residual ratio : 0.000559269 - Slope : -0.473826 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.87335 - Final Residual ratio : 0.00432291 - Residual ratio : 0.000628938 - Slope : -0.457935 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.66683 - Final Residual ratio : 0.00286767 - Residual ratio : 0.000506045 - Slope : -0.377598 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.18969 - Final Residual ratio : 0.00303313 - Residual ratio : 0.000723951 - Slope : -0.27911 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4091 -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.06764 - Final Residual ratio : 0.00183059 - Residual ratio : 0.000596741 - Slope : -0.191613 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 52.2495 - Final Residual ratio : 0.0504713 - Residual ratio : 0.000965968 - Slope : -4.34992 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.41726 - Final Residual ratio : 0.00578858 - Residual ratio : 0.000614678 - Slope : -0.588217 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.28923 - Final Residual ratio : 0.00715267 - Residual ratio : 0.000769996 - Slope : -0.618805 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.92572 - Final Residual ratio : 0.00253139 - Residual ratio : 0.000513912 - Slope : -0.328213 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4141 -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.97585 - Final Residual ratio : 0.00365331 - Residual ratio : 0.000611346 - Slope : -0.398146 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.11267 - Final Residual ratio : 0.00209159 - Residual ratio : 0.000409098 - Slope : -0.340705 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.5915 - Final Residual ratio : 0.00082372 - Residual ratio : 0.000179401 - Slope : -0.286917 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.88177 - Final Residual ratio : 0.00293853 - Residual ratio : 0.000757008 - Slope : -0.258589 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.20627 - Final Residual ratio : 0.00262949 - Residual ratio : 0.000820109 - Slope : -0.213576 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4191 -dimension in distance computation 2 -elements_to_solve.size() : 25 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.99947 - Final Residual ratio : 0.00295531 - Residual ratio : 0.000985279 - Slope : -0.199768 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84127 - Final Residual ratio : 0.00204385 - Residual ratio : 0.000719342 - Slope : -0.177452 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 58.7457 - Final Residual ratio : 0.0401318 - Residual ratio : 0.000683145 - Slope : -4.19326 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.4231 - Final Residual ratio : 0.00647551 - Residual ratio : 0.000566878 - Slope : -0.815473 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.42727 - Final Residual ratio : 0.00511369 - Residual ratio : 0.000688502 - Slope : -0.463885 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4241 -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3916 - Final Residual ratio : 0.0136075 - Residual ratio : 0.000830156 - Slope : -1.02362 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.4335 - Final Residual ratio : 0.0250546 - Residual ratio : 0.000881163 - Slope : -1.8939 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.5663 - Final Residual ratio : 0.0298134 - Residual ratio : 0.000915466 - Slope : -2.32404 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.8249 - Final Residual ratio : 0.0100975 - Residual ratio : 0.000681119 - Slope : -0.987655 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.92765 - Final Residual ratio : 0.00469829 - Residual ratio : 0.000526263 - Slope : -0.524879 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4291 -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.55657 - Final Residual ratio : 0.00514551 - Residual ratio : 0.000680932 - Slope : -0.471964 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.38765 - Final Residual ratio : 0.00466037 - Residual ratio : 0.00072959 - Slope : -0.398937 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.21137 - Final Residual ratio : 0.00371412 - Residual ratio : 0.000712696 - Slope : -0.371975 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.27637 - Final Residual ratio : 0.00257626 - Residual ratio : 0.00060244 - Slope : -0.267112 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.81715 - Final Residual ratio : 0.00290887 - Residual ratio : 0.000762053 - Slope : -0.23839 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4341 -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.93968 - Final Residual ratio : 0.00372514 - Residual ratio : 0.000945542 - Slope : -0.28114 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.99051 - Final Residual ratio : 0.0035573 - Residual ratio : 0.000891439 - Slope : -0.284782 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.01296 - Final Residual ratio : 0.00200752 - Residual ratio : 0.000500259 - Slope : -0.286496 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.81562 - Final Residual ratio : 0.00307693 - Residual ratio : 0.000806402 - Slope : -0.293273 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.4278 - Final Residual ratio : 0.00330345 - Residual ratio : 0.000963721 - Slope : -0.2283 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4391 -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.18277 - Final Residual ratio : 0.00281264 - Residual ratio : 0.000883709 - Slope : -0.22714 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.62171 - Final Residual ratio : 0.00182466 - Residual ratio : 0.00069598 - Slope : -0.187135 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.49558 - Final Residual ratio : 0.00213132 - Residual ratio : 0.000854039 - Slope : -0.15584 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.61201 - Final Residual ratio : 0.00219346 - Residual ratio : 0.00083976 - Slope : -0.163113 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.79231 - Final Residual ratio : 0.00142414 - Residual ratio : 0.000510022 - Slope : -0.186059 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4441 -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84722 - Final Residual ratio : 0.00238623 - Residual ratio : 0.00083809 - Slope : -0.177802 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.73038 - Final Residual ratio : 0.00186624 - Residual ratio : 0.000683508 - Slope : -0.160501 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.46805 - Final Residual ratio : 0.00196422 - Residual ratio : 0.000795861 - Slope : -0.164406 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.06672 - Final Residual ratio : 0.00124178 - Residual ratio : 0.000600849 - Slope : -0.147534 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.6445 - Final Residual ratio : 0.00133354 - Residual ratio : 0.000810911 - Slope : -0.109544 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4491 -dimension in distance computation 2 -elements_to_solve.size() : 26 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43866 - Final Residual ratio : 0.00130917 - Residual ratio : 0.000909993 - Slope : -0.0898344 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.8681 - Final Residual ratio : 0.0361704 - Residual ratio : 0.000955168 - Slope : -3.43927 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.22015 - Final Residual ratio : 0.00550164 - Residual ratio : 0.000884486 - Slope : -0.41431 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.48009 - Final Residual ratio : 0.00572243 - Residual ratio : 0.000765022 - Slope : -0.533883 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.19993 - Final Residual ratio : 0.00173671 - Residual ratio : 0.000542732 - Slope : -0.213213 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4541 -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.73051 - Final Residual ratio : 0.00263166 - Residual ratio : 0.000963798 - Slope : -0.194848 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.62582 - Final Residual ratio : 0.00147482 - Residual ratio : 0.000561662 - Slope : -0.201872 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.38658 - Final Residual ratio : 0.00229771 - Residual ratio : 0.000962761 - Slope : -0.170306 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.07556 - Final Residual ratio : 0.00147874 - Residual ratio : 0.000712453 - Slope : -0.12963 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76166 - Final Residual ratio : 0.0017484 - Residual ratio : 0.000992474 - Slope : -0.109995 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4591 -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48474 - Final Residual ratio : 0.00109008 - Residual ratio : 0.000734191 - Slope : -0.0872734 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37307 - Final Residual ratio : 0.00116239 - Residual ratio : 0.00084656 - Slope : -0.0857443 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34248 - Final Residual ratio : 0.000841911 - Residual ratio : 0.000627132 - Slope : -0.0894425 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32787 - Final Residual ratio : 0.00119902 - Residual ratio : 0.000902961 - Slope : -0.0947625 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26581 - Final Residual ratio : 0.00125942 - Residual ratio : 0.000994951 - Slope : -0.0843033 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4641 -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19099 - Final Residual ratio : 0.000768541 - Residual ratio : 0.000645298 - Slope : -0.0793478 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.7245 - Final Residual ratio : 0.0104995 - Residual ratio : 0.000713065 - Slope : -0.919626 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.1751 - Final Residual ratio : 0.0220376 - Residual ratio : 0.000810947 - Slope : -1.69707 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.3942 - Final Residual ratio : 0.0224481 - Residual ratio : 0.00071504 - Slope : -2.24084 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8627 - Final Residual ratio : 0.0126052 - Residual ratio : 0.000979982 - Slope : -0.98847 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4691 -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.37426 - Final Residual ratio : 0.0042168 - Residual ratio : 0.000784628 - Slope : -0.383575 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.59617 - Final Residual ratio : 0.00272006 - Residual ratio : 0.00059181 - Slope : -0.30623 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.36846 - Final Residual ratio : 0.00335926 - Residual ratio : 0.00076898 - Slope : -0.291007 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.0426 - Final Residual ratio : 0.00284476 - Residual ratio : 0.000703697 - Slope : -0.269317 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.57305 - Final Residual ratio : 0.00332187 - Residual ratio : 0.000929701 - Slope : -0.297477 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4741 -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.95857 - Final Residual ratio : 0.00291897 - Residual ratio : 0.000986614 - Slope : -0.227358 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.52113 - Final Residual ratio : 0.0013162 - Residual ratio : 0.000522067 - Slope : -0.179987 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.2003 - Final Residual ratio : 0.00169416 - Residual ratio : 0.000769969 - Slope : -0.137413 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.06507 - Final Residual ratio : 0.0014372 - Residual ratio : 0.000695959 - Slope : -0.128977 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.04608 - Final Residual ratio : 0.00158222 - Residual ratio : 0.000773293 - Slope : -0.146036 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4791 -dimension in distance computation 2 -elements_to_solve.size() : 27 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.86998 - Final Residual ratio : 0.00116479 - Residual ratio : 0.00062289 - Slope : -0.133487 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.9273 - Final Residual ratio : 0.00161172 - Residual ratio : 0.000836257 - Slope : -0.120356 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76272 - Final Residual ratio : 0.00126938 - Residual ratio : 0.000720127 - Slope : -0.103615 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 93.047 - Final Residual ratio : 0.0503471 - Residual ratio : 0.000541093 - Slope : -11.6246 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.4552 - Final Residual ratio : 0.013 - Residual ratio : 0.000635539 - Slope : -1.46015 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4841 -dimension in distance computation 2 -elements_to_solve.size() : 28 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.7066 - Final Residual ratio : 0.00944624 - Residual ratio : 0.000689175 - Slope : -0.978368 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.22914 - Final Residual ratio : 0.0041138 - Residual ratio : 0.000660412 - Slope : -0.389064 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.3733 - Final Residual ratio : 0.00952664 - Residual ratio : 0.000662801 - Slope : -0.957585 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.55169 - Final Residual ratio : 0.00545052 - Residual ratio : 0.000721761 - Slope : -0.628853 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.86557 - Final Residual ratio : 0.00482283 - Residual ratio : 0.000543996 - Slope : -0.681596 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4891 -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.43795 - Final Residual ratio : 0.00514276 - Residual ratio : 0.000691421 - Slope : -0.571755 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.73748 - Final Residual ratio : 0.0057176 - Residual ratio : 0.000848627 - Slope : -0.56098 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.60531 - Final Residual ratio : 0.00293152 - Residual ratio : 0.00052299 - Slope : -0.373492 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.20955 - Final Residual ratio : 0.00303597 - Residual ratio : 0.000721211 - Slope : -0.300465 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84437 - Final Residual ratio : 0.00196175 - Residual ratio : 0.000689696 - Slope : -0.189494 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4941 -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.9824 - Final Residual ratio : 0.00172904 - Residual ratio : 0.000872196 - Slope : -0.141476 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.47371 - Final Residual ratio : 0.001888 - Residual ratio : 0.000763223 - Slope : -0.154489 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.36232 - Final Residual ratio : 0.00271824 - Residual ratio : 0.000808442 - Slope : -0.279967 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.09644 - Final Residual ratio : 0.00335833 - Residual ratio : 0.000819816 - Slope : -0.272872 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.50112 - Final Residual ratio : 0.00376053 - Residual ratio : 0.000835465 - Slope : -0.299824 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.4991 -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.59056 - Final Residual ratio : 0.00308095 - Residual ratio : 0.000671149 - Slope : -0.305832 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.28771 - Final Residual ratio : 0.00270546 - Residual ratio : 0.00063098 - Slope : -0.306072 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -writing a 2D mesh -0.001 -******** CURRENT TIME = 0.5011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.72961 - Final Residual ratio : 0.00293066 - Residual ratio : 0.000785782 - Slope : -0.266191 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.06427 - Final Residual ratio : 0.00194228 - Residual ratio : 0.000633846 - Slope : -0.191396 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.4628 - Final Residual ratio : 0.00207797 - Residual ratio : 0.000843741 - Slope : -0.153795 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5041 -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.22378 - Final Residual ratio : 0.00160342 - Residual ratio : 0.000721034 - Slope : -0.138886 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.10918 - Final Residual ratio : 0.00153786 - Residual ratio : 0.000729128 - Slope : -0.150546 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.24266 - Final Residual ratio : 0.00149241 - Residual ratio : 0.000665463 - Slope : -0.140073 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.36408 - Final Residual ratio : 0.00128653 - Residual ratio : 0.000544201 - Slope : -0.147675 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.34006 - Final Residual ratio : 0.00113559 - Residual ratio : 0.000485283 - Slope : -0.146183 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5091 -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.08065 - Final Residual ratio : 0.00196686 - Residual ratio : 0.000945308 - Slope : -0.138579 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.73115 - Final Residual ratio : 0.00143257 - Residual ratio : 0.000827527 - Slope : -0.115314 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30771 - Final Residual ratio : 0.00110742 - Residual ratio : 0.000846842 - Slope : -0.0933288 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00389 - Final Residual ratio : 0.0006246 - Residual ratio : 0.00062218 - Slope : -0.0627041 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07756 - Final Residual ratio : 0.000721533 - Residual ratio : 0.000669602 - Slope : -0.0673021 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5141 -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43103 - Final Residual ratio : 0.000741646 - Residual ratio : 0.000518261 - Slope : -0.0953524 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83804 - Final Residual ratio : 0.00154657 - Residual ratio : 0.000841422 - Slope : -0.131178 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11508 - Final Residual ratio : 0.000734923 - Residual ratio : 0.000347468 - Slope : -0.140956 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.23105 - Final Residual ratio : 0.000829353 - Residual ratio : 0.000371732 - Slope : -0.148681 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.18004 - Final Residual ratio : 0.00176557 - Residual ratio : 0.000809881 - Slope : -0.16756 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5191 -dimension in distance computation 2 -elements_to_solve.size() : 29 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.09846 - Final Residual ratio : 0.00139354 - Residual ratio : 0.00066408 - Slope : -0.139804 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7302 - Final Residual ratio : 0.00158749 - Residual ratio : 0.000917518 - Slope : -0.115241 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.6332 - Final Residual ratio : 0.0103183 - Residual ratio : 0.000756855 - Slope : -0.851428 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.0457 - Final Residual ratio : 0.0199036 - Residual ratio : 0.000735923 - Slope : -1.68911 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.7166 - Final Residual ratio : 0.021527 - Residual ratio : 0.000678729 - Slope : -2.26393 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5241 -dimension in distance computation 2 -elements_to_solve.size() : 30 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.3599 - Final Residual ratio : 0.0141048 - Residual ratio : 0.000692773 - Slope : -1.35639 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.49544 - Final Residual ratio : 0.00377079 - Residual ratio : 0.000686168 - Slope : -0.323039 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.94478 - Final Residual ratio : 0.00484605 - Residual ratio : 0.000980035 - Slope : -0.352852 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.71593 - Final Residual ratio : 0.00282535 - Residual ratio : 0.000599109 - Slope : -0.33665 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.34157 - Final Residual ratio : 0.00332762 - Residual ratio : 0.000766455 - Slope : -0.289216 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5291 -dimension in distance computation 2 -elements_to_solve.size() : 30 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.83203 - Final Residual ratio : 0.00279824 - Residual ratio : 0.000730222 - Slope : -0.255282 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.18647 - Final Residual ratio : 0.00286566 - Residual ratio : 0.00089932 - Slope : -0.21224 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.64271 - Final Residual ratio : 0.00193644 - Residual ratio : 0.000732749 - Slope : -0.165048 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.30964 - Final Residual ratio : 0.00193348 - Residual ratio : 0.000837135 - Slope : -0.144231 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.25341 - Final Residual ratio : 0.0016384 - Residual ratio : 0.000727075 - Slope : -0.140736 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5341 -dimension in distance computation 2 -elements_to_solve.size() : 30 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.31253 - Final Residual ratio : 0.0020213 - Residual ratio : 0.000874064 - Slope : -0.165037 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 92.0514 - Final Residual ratio : 0.0919275 - Residual ratio : 0.000998654 - Slope : -7.66329 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.6997 - Final Residual ratio : 0.0110538 - Residual ratio : 0.000561114 - Slope : -1.51451 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.2298 - Final Residual ratio : 0.00747008 - Residual ratio : 0.000564643 - Slope : -1.0171 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.95958 - Final Residual ratio : 0.00679482 - Residual ratio : 0.000976326 - Slope : -0.496627 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5391 -dimension in distance computation 2 -elements_to_solve.size() : 31 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.44499 - Final Residual ratio : 0.00557206 - Residual ratio : 0.000748431 - Slope : -0.531387 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.70355 - Final Residual ratio : 0.00801012 - Residual ratio : 0.000920328 - Slope : -0.869554 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.68405 - Final Residual ratio : 0.00926601 - Residual ratio : 0.000956832 - Slope : -0.691056 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1755 - Final Residual ratio : 0.00589209 - Residual ratio : 0.000579048 - Slope : -0.782276 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.034 - Final Residual ratio : 0.00890165 - Residual ratio : 0.000887145 - Slope : -0.835429 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5441 -dimension in distance computation 2 -elements_to_solve.size() : 31 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.21844 - Final Residual ratio : 0.00531444 - Residual ratio : 0.000576501 - Slope : -0.767761 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.8629 - Final Residual ratio : 0.00469571 - Residual ratio : 0.000597198 - Slope : -0.714382 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.13257 - Final Residual ratio : 0.00314582 - Residual ratio : 0.000512969 - Slope : -0.510785 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.32144 - Final Residual ratio : 0.00281451 - Residual ratio : 0.000651289 - Slope : -0.308473 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.0114 - Final Residual ratio : 0.00209544 - Residual ratio : 0.000695837 - Slope : -0.188082 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5491 -dimension in distance computation 2 -elements_to_solve.size() : 31 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.00912 - Final Residual ratio : 0.00241359 - Residual ratio : 0.000802092 - Slope : -0.187919 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.06387 - Final Residual ratio : 0.0031039 - Residual ratio : 0.00076378 - Slope : -0.290055 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.1156 - Final Residual ratio : 0.00356506 - Residual ratio : 0.0006969 - Slope : -0.365145 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.79673 - Final Residual ratio : 0.0053038 - Residual ratio : 0.000914964 - Slope : -0.445494 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.99082 - Final Residual ratio : 0.00505963 - Residual ratio : 0.000844565 - Slope : -0.498813 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5541 -dimension in distance computation 2 -elements_to_solve.size() : 31 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.70083 - Final Residual ratio : 0.00475078 - Residual ratio : 0.000833348 - Slope : -0.474674 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.02273 - Final Residual ratio : 0.00398127 - Residual ratio : 0.000792651 - Slope : -0.418229 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.08511 - Final Residual ratio : 0.00316732 - Residual ratio : 0.000775332 - Slope : -0.408195 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 78.2712 - Final Residual ratio : 0.0565708 - Residual ratio : 0.000722753 - Slope : -5.21431 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.8833 - Final Residual ratio : 0.0163055 - Residual ratio : 0.000965777 - Slope : -1.05419 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5591 -dimension in distance computation 2 -elements_to_solve.size() : 31 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.4275 - Final Residual ratio : 0.0128127 - Residual ratio : 0.000830511 - Slope : -1.10105 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.9189 - Final Residual ratio : 0.0116505 - Residual ratio : 0.000650181 - Slope : -1.19382 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.06768 - Final Residual ratio : 0.00257771 - Residual ratio : 0.000633705 - Slope : -0.254069 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.60271 - Final Residual ratio : 0.00331028 - Residual ratio : 0.00091883 - Slope : -0.276877 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.43997 - Final Residual ratio : 0.00248946 - Residual ratio : 0.000723687 - Slope : -0.245534 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5641 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.8118 - Final Residual ratio : 0.012064 - Residual ratio : 0.000873455 - Slope : -1.25452 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.48108 - Final Residual ratio : 0.00219066 - Residual ratio : 0.000882948 - Slope : -0.206574 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82229 - Final Residual ratio : 0.00144457 - Residual ratio : 0.000792725 - Slope : -0.140065 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43457 - Final Residual ratio : 0.00141695 - Residual ratio : 0.000987718 - Slope : -0.110242 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.74016 - Final Residual ratio : 0.000999318 - Residual ratio : 0.000574266 - Slope : -0.124226 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5691 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.37466 - Final Residual ratio : 0.00161558 - Residual ratio : 0.000680341 - Slope : -0.197754 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.96413 - Final Residual ratio : 0.00157712 - Residual ratio : 0.000532068 - Slope : -0.227889 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.34617 - Final Residual ratio : 0.00203874 - Residual ratio : 0.000609275 - Slope : -0.238867 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.4642 - Final Residual ratio : 0.00312357 - Residual ratio : 0.000901669 - Slope : -0.24722 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.32433 - Final Residual ratio : 0.00175047 - Residual ratio : 0.000526562 - Slope : -0.237327 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5741 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.99664 - Final Residual ratio : 0.00152035 - Residual ratio : 0.000507351 - Slope : -0.213937 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.50563 - Final Residual ratio : 0.00219568 - Residual ratio : 0.000876299 - Slope : -0.178817 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03107 - Final Residual ratio : 0.00117839 - Residual ratio : 0.000580182 - Slope : -0.144992 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7253 - Final Residual ratio : 0.00106826 - Residual ratio : 0.000619176 - Slope : -0.123159 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.69912 - Final Residual ratio : 0.00141942 - Residual ratio : 0.000835386 - Slope : -0.106106 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5791 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.91295 - Final Residual ratio : 0.0013233 - Residual ratio : 0.000691757 - Slope : -0.127442 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.04988 - Final Residual ratio : 0.00186631 - Residual ratio : 0.00091045 - Slope : -0.170668 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11972 - Final Residual ratio : 0.0019035 - Residual ratio : 0.000898 - Slope : -0.162909 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03101 - Final Residual ratio : 0.00176744 - Residual ratio : 0.00087023 - Slope : -0.156095 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.78496 - Final Residual ratio : 0.0016685 - Residual ratio : 0.000934757 - Slope : -0.137176 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5841 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38579 - Final Residual ratio : 0.000925978 - Residual ratio : 0.000668193 - Slope : -0.106528 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05159 - Final Residual ratio : 0.000739611 - Residual ratio : 0.000703327 - Slope : -0.0700567 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.916647 - Final Residual ratio : 0.000843844 - Residual ratio : 0.000920577 - Slope : -0.0610535 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12453 - Final Residual ratio : 0.00105311 - Residual ratio : 0.00093649 - Slope : -0.0864215 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48523 - Final Residual ratio : 0.0014615 - Residual ratio : 0.00098402 - Slope : -0.123647 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5891 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.79162 - Final Residual ratio : 0.000831626 - Residual ratio : 0.000464176 - Slope : -0.127913 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02725 - Final Residual ratio : 0.00183924 - Residual ratio : 0.000907255 - Slope : -0.144672 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.09302 - Final Residual ratio : 0.00196667 - Residual ratio : 0.000939635 - Slope : -0.149361 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00681 - Final Residual ratio : 0.00149444 - Residual ratio : 0.000744685 - Slope : -0.154255 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.79366 - Final Residual ratio : 0.00106143 - Residual ratio : 0.000591768 - Slope : -0.137892 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5941 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52957 - Final Residual ratio : 0.00140153 - Residual ratio : 0.000916292 - Slope : -0.109155 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22871 - Final Residual ratio : 0.000530045 - Residual ratio : 0.000431382 - Slope : -0.0877275 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 76.2823 - Final Residual ratio : 0.0570424 - Residual ratio : 0.00074778 - Slope : -5.08168 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.294 - Final Residual ratio : 0.0158249 - Residual ratio : 0.000971212 - Slope : -1.01739 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.1366 - Final Residual ratio : 0.0129277 - Residual ratio : 0.000854071 - Slope : -1.00824 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.5991 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.3999 - Final Residual ratio : 0.0120189 - Residual ratio : 0.000690745 - Slope : -1.15919 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.52613 - Final Residual ratio : 0.00167298 - Residual ratio : 0.000662268 - Slope : -0.168297 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4344 - Final Residual ratio : 0.0011906 - Residual ratio : 0.000830029 - Slope : -0.102372 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26497 - Final Residual ratio : 0.000798942 - Residual ratio : 0.000631592 - Slope : -0.0902976 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08577 - Final Residual ratio : 0.000628554 - Residual ratio : 0.000578902 - Slope : -0.0723428 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6041 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.798747 - Final Residual ratio : 0.000485256 - Residual ratio : 0.000607522 - Slope : -0.0532174 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.7988 - Final Residual ratio : 0.00765606 - Residual ratio : 0.000708972 - Slope : -1.19902 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 93.0417 - Final Residual ratio : 0.0629872 - Residual ratio : 0.000676978 - Slope : -11.6223 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.2905 - Final Residual ratio : 0.0193738 - Residual ratio : 0.000909975 - Slope : -1.51936 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.6716 - Final Residual ratio : 0.0126431 - Residual ratio : 0.00080675 - Slope : -1.20453 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6091 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.12369 - Final Residual ratio : 0.00487357 - Residual ratio : 0.000684135 - Slope : -0.474588 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.13564 - Final Residual ratio : 0.00595156 - Residual ratio : 0.000731542 - Slope : -0.580692 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.36625 - Final Residual ratio : 0.00854479 - Residual ratio : 0.000912296 - Slope : -0.719823 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.2576 - Final Residual ratio : 0.00679546 - Residual ratio : 0.000662478 - Slope : -0.788527 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.656 - Final Residual ratio : 0.00967882 - Residual ratio : 0.000908295 - Slope : -1.06464 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6141 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.474 - Final Residual ratio : 0.00738904 - Residual ratio : 0.000705466 - Slope : -0.805123 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.71433 - Final Residual ratio : 0.00672755 - Residual ratio : 0.000692538 - Slope : -0.746739 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.44475 - Final Residual ratio : 0.00626261 - Residual ratio : 0.000741598 - Slope : -0.703207 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.6998 - Final Residual ratio : 0.0246628 - Residual ratio : 0.000778011 - Slope : -2.43655 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.3834 - Final Residual ratio : 0.0171623 - Residual ratio : 0.000766739 - Slope : -1.72048 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6191 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.756 - Final Residual ratio : 0.0137116 - Residual ratio : 0.000660608 - Slope : -1.72852 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.10824 - Final Residual ratio : 0.00827227 - Residual ratio : 0.000908219 - Slope : -0.75833 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.15717 - Final Residual ratio : 0.00637047 - Residual ratio : 0.000780965 - Slope : -0.626985 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.65253 - Final Residual ratio : 0.00748538 - Residual ratio : 0.000978157 - Slope : -0.849449 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.01475 - Final Residual ratio : 0.00613103 - Residual ratio : 0.000874019 - Slope : -0.539125 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6241 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.20518 - Final Residual ratio : 0.00125769 - Residual ratio : 0.000202685 - Slope : -0.413595 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.15177 - Final Residual ratio : 0.00279936 - Residual ratio : 0.000543378 - Slope : -0.396075 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.02997 - Final Residual ratio : 0.00310761 - Residual ratio : 0.000771125 - Slope : -0.309758 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.97751 - Final Residual ratio : 0.0029647 - Residual ratio : 0.000995698 - Slope : -0.228811 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.24978 - Final Residual ratio : 0.0016726 - Residual ratio : 0.00074345 - Slope : -0.160579 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6291 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.4683 - Final Residual ratio : 0.0202907 - Residual ratio : 0.000903083 - Slope : -2.49422 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.3102 - Final Residual ratio : 0.0150707 - Residual ratio : 0.000780452 - Slope : -2.41189 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.7209 - Final Residual ratio : 0.025122 - Residual ratio : 0.000906249 - Slope : -3.95654 - Tolerance : 0.001 - Number of iterations : 7 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 75.9682 - Final Residual ratio : 0.0556427 - Residual ratio : 0.000732448 - Slope : -5.06083 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5174 - Final Residual ratio : 0.0149304 - Residual ratio : 0.000903923 - Slope : -1.0314 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6341 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.9096 - Final Residual ratio : 0.012544 - Residual ratio : 0.000841341 - Slope : -0.993134 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.2866 - Final Residual ratio : 0.0103284 - Residual ratio : 0.000597478 - Slope : -1.15175 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.86196 - Final Residual ratio : 0.00272474 - Residual ratio : 0.000952053 - Slope : -0.190616 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.49663 - Final Residual ratio : 0.00143456 - Residual ratio : 0.000574597 - Slope : -0.166346 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.72308 - Final Residual ratio : 0.00196431 - Residual ratio : 0.000721355 - Slope : -0.181408 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6391 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.75828 - Final Residual ratio : 0.00160556 - Residual ratio : 0.000582087 - Slope : -0.183778 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.6718 - Final Residual ratio : 0.002348 - Residual ratio : 0.000878806 - Slope : -0.177964 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.4607 - Final Residual ratio : 0.00133829 - Residual ratio : 0.000543866 - Slope : -0.163958 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.17233 - Final Residual ratio : 0.000876154 - Residual ratio : 0.000403324 - Slope : -0.144764 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.85622 - Final Residual ratio : 0.00106347 - Residual ratio : 0.000572921 - Slope : -0.123677 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6441 -dimension in distance computation 2 -elements_to_solve.size() : 32 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52945 - Final Residual ratio : 0.00140858 - Residual ratio : 0.000920972 - Slope : -0.10187 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30885 - Final Residual ratio : 0.000732135 - Residual ratio : 0.000559374 - Slope : -0.0817571 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15736 - Final Residual ratio : 0.000936951 - Residual ratio : 0.00080956 - Slope : -0.0770948 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.252 - Final Residual ratio : 0.00860198 - Residual ratio : 0.000839057 - Slope : -1.02434 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.952951 - Final Residual ratio : 0.000541358 - Residual ratio : 0.000568086 - Slope : -0.063494 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6491 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.20592 - Final Residual ratio : 0.00104544 - Residual ratio : 0.000866923 - Slope : -0.0860627 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11898 - Final Residual ratio : 0.000992661 - Residual ratio : 0.000887111 - Slope : -0.0798564 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03435 - Final Residual ratio : 0.000902203 - Residual ratio : 0.000872238 - Slope : -0.073818 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.944853 - Final Residual ratio : 0.000861209 - Residual ratio : 0.000911474 - Slope : -0.067428 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.87273 - Final Residual ratio : 0.000620905 - Residual ratio : 0.000711452 - Slope : -0.0622935 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6541 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.859115 - Final Residual ratio : 0.000634125 - Residual ratio : 0.000738115 - Slope : -0.066037 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.809132 - Final Residual ratio : 0.000501528 - Residual ratio : 0.000619834 - Slope : -0.0505394 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.818906 - Final Residual ratio : 0.000570565 - Residual ratio : 0.00069674 - Slope : -0.051146 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.823747 - Final Residual ratio : 0.000658586 - Residual ratio : 0.000799499 - Slope : -0.0548726 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.811669 - Final Residual ratio : 0.000424848 - Residual ratio : 0.000523426 - Slope : -0.0540829 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6591 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.811506 - Final Residual ratio : 0.000191574 - Residual ratio : 0.000236072 - Slope : -0.0540876 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.723861 - Final Residual ratio : 0.000403923 - Residual ratio : 0.000558011 - Slope : -0.0602881 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.67569 - Final Residual ratio : 0.000645212 - Residual ratio : 0.000954894 - Slope : -0.0519265 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.636987 - Final Residual ratio : 0.000524579 - Residual ratio : 0.000823532 - Slope : -0.0489586 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.620455 - Final Residual ratio : 0.00041731 - Residual ratio : 0.000672588 - Slope : -0.0476952 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6641 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.63246 - Final Residual ratio : 0.000542016 - Residual ratio : 0.000856997 - Slope : -0.0394949 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.637087 - Final Residual ratio : 0.000340509 - Residual ratio : 0.000534477 - Slope : -0.0397967 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.65829 - Final Residual ratio : 0.000352115 - Residual ratio : 0.000534893 - Slope : -0.0438625 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.66126 - Final Residual ratio : 0.000387623 - Residual ratio : 0.000586188 - Slope : -0.0440582 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.642924 - Final Residual ratio : 0.000414547 - Residual ratio : 0.000644785 - Slope : -0.0428339 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6691 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.574641 - Final Residual ratio : 0.000257212 - Residual ratio : 0.000447605 - Slope : -0.0382923 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 75.0254 - Final Residual ratio : 0.057373 - Residual ratio : 0.000764715 - Slope : -4.99787 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.9349 - Final Residual ratio : 0.0170558 - Residual ratio : 0.000657641 - Slope : -1.72785 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.1206 - Final Residual ratio : 0.0126054 - Residual ratio : 0.000448263 - Slope : -1.65341 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.6109 - Final Residual ratio : 0.0117562 - Residual ratio : 0.000570388 - Slope : -1.37328 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6741 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.0009 - Final Residual ratio : 0.0126369 - Residual ratio : 0.000743307 - Slope : -1.21345 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.27207 - Final Residual ratio : 0.00177133 - Residual ratio : 0.000779611 - Slope : -0.141894 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.851885 - Final Residual ratio : 0.000612701 - Residual ratio : 0.00071923 - Slope : -0.0567515 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.781122 - Final Residual ratio : 0.000635047 - Residual ratio : 0.000812993 - Slope : -0.0487805 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.7683 - Final Residual ratio : 0.0146613 - Residual ratio : 0.000929793 - Slope : -1.31281 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6791 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 47.2342 - Final Residual ratio : 0.0453348 - Residual ratio : 0.000959787 - Slope : -3.93241 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 35.2663 - Final Residual ratio : 0.0343437 - Residual ratio : 0.000973839 - Slope : -3.52319 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.6192 - Final Residual ratio : 0.0153251 - Residual ratio : 0.000869799 - Slope : -1.35414 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3001 - Final Residual ratio : 0.00790566 - Residual ratio : 0.000767529 - Slope : -0.686149 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.92989 - Final Residual ratio : 0.00549867 - Residual ratio : 0.00069341 - Slope : -0.495275 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6841 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.82633 - Final Residual ratio : 0.00539546 - Residual ratio : 0.000689399 - Slope : -0.558638 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.14063 - Final Residual ratio : 0.00737286 - Residual ratio : 0.000806603 - Slope : -1.01481 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.5505 - Final Residual ratio : 0.00907492 - Residual ratio : 0.00086014 - Slope : -0.810879 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.4198 - Final Residual ratio : 0.00642773 - Residual ratio : 0.000562859 - Slope : -0.81524 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.529 - Final Residual ratio : 0.00983556 - Residual ratio : 0.000853116 - Slope : -0.886088 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6891 -dimension in distance computation 2 -elements_to_solve.size() : 33 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.8622 - Final Residual ratio : 0.00872363 - Residual ratio : 0.000803118 - Slope : -0.834883 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.5591 - Final Residual ratio : 0.0130196 - Residual ratio : 0.00089426 - Slope : -1.21217 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.74831 - Final Residual ratio : 0.0064449 - Residual ratio : 0.000831781 - Slope : -0.645156 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.82817 - Final Residual ratio : 0.0038971 - Residual ratio : 0.000668666 - Slope : -0.448021 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.17328 - Final Residual ratio : 0.00331671 - Residual ratio : 0.000794748 - Slope : -0.297855 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6941 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5074 - Final Residual ratio : 0.0026544 - Residual ratio : 0.000756799 - Slope : -0.269596 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.06024 - Final Residual ratio : 0.00269366 - Residual ratio : 0.000663424 - Slope : -0.270503 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.02446 - Final Residual ratio : 0.00440994 - Residual ratio : 0.000877694 - Slope : -0.358575 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.77493 - Final Residual ratio : 0.0054016 - Residual ratio : 0.000935353 - Slope : -0.412109 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.8334 - Final Residual ratio : 0.0188297 - Residual ratio : 0.000903825 - Slope : -1.60112 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.6991 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.3968 - Final Residual ratio : 0.0423729 - Residual ratio : 0.000913271 - Slope : -3.56573 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.1586 - Final Residual ratio : 0.0259539 - Residual ratio : 0.000955643 - Slope : -2.71326 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 13.8611 - Final Residual ratio : 0.0129014 - Residual ratio : 0.000930764 - Slope : -1.15402 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 74.4319 - Final Residual ratio : 0.0556505 - Residual ratio : 0.000747669 - Slope : -4.95842 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.3562 - Final Residual ratio : 0.0159891 - Residual ratio : 0.000606655 - Slope : -1.75601 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7041 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.3465 - Final Residual ratio : 0.0125512 - Residual ratio : 0.00044278 - Slope : -1.6667 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.7365 - Final Residual ratio : 0.0211867 - Residual ratio : 0.000974707 - Slope : -1.44768 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.1993 - Final Residual ratio : 0.0117473 - Residual ratio : 0.000611861 - Slope : -1.19922 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3144 - Final Residual ratio : 0.00768427 - Residual ratio : 0.000745002 - Slope : -0.644171 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.3312 - Final Residual ratio : 0.010314 - Residual ratio : 0.000998329 - Slope : -0.938265 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7091 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.76166 - Final Residual ratio : 0.00593824 - Residual ratio : 0.000608323 - Slope : -0.75044 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.51131 - Final Residual ratio : 0.00570878 - Residual ratio : 0.00067073 - Slope : -0.607543 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.79145 - Final Residual ratio : 0.00468635 - Residual ratio : 0.000690037 - Slope : -0.484769 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.95143 - Final Residual ratio : 0.00340928 - Residual ratio : 0.000688545 - Slope : -0.329868 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.62162 - Final Residual ratio : 0.00265293 - Residual ratio : 0.000732526 - Slope : -0.226185 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7141 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5793 - Final Residual ratio : 0.00205368 - Residual ratio : 0.000573766 - Slope : -0.223578 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.61562 - Final Residual ratio : 0.00262907 - Residual ratio : 0.000569602 - Slope : -0.288312 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.70707 - Final Residual ratio : 0.00494587 - Residual ratio : 0.000866621 - Slope : -0.380142 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.41805 - Final Residual ratio : 0.00622529 - Residual ratio : 0.000969966 - Slope : -0.712425 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.59878 - Final Residual ratio : 0.0053819 - Residual ratio : 0.00081559 - Slope : -0.507185 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7191 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.24194 - Final Residual ratio : 0.00552918 - Residual ratio : 0.000885811 - Slope : -0.479724 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.42636 - Final Residual ratio : 0.0049012 - Residual ratio : 0.00090322 - Slope : -0.417035 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.33135 - Final Residual ratio : 0.00364969 - Residual ratio : 0.000842622 - Slope : -0.3329 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.25281 - Final Residual ratio : 0.00291147 - Residual ratio : 0.000895064 - Slope : -0.232136 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.66294 - Final Residual ratio : 0.00157673 - Residual ratio : 0.000592103 - Slope : -0.177424 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7241 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.924 - Final Residual ratio : 0.00235648 - Residual ratio : 0.000805909 - Slope : -0.194776 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.59096 - Final Residual ratio : 0.00355613 - Residual ratio : 0.000990299 - Slope : -0.256243 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.21477 - Final Residual ratio : 0.00356279 - Residual ratio : 0.000845311 - Slope : -0.300801 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.53884 - Final Residual ratio : 0.00377256 - Residual ratio : 0.000831173 - Slope : -0.323934 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48104 - Final Residual ratio : 0.00305187 - Residual ratio : 0.000681062 - Slope : -0.319856 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7291 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.03216 - Final Residual ratio : 0.00361155 - Residual ratio : 0.000895686 - Slope : -0.309888 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.33025 - Final Residual ratio : 0.00289239 - Residual ratio : 0.00086852 - Slope : -0.255951 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.49866 - Final Residual ratio : 0.00167237 - Residual ratio : 0.000669307 - Slope : -0.178356 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.86661 - Final Residual ratio : 0.00162935 - Residual ratio : 0.000872892 - Slope : -0.124332 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.88789 - Final Residual ratio : 0.00108718 - Residual ratio : 0.000575869 - Slope : -0.117925 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7341 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.42529 - Final Residual ratio : 0.00194061 - Residual ratio : 0.000800156 - Slope : -0.269261 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 73.4204 - Final Residual ratio : 0.0658237 - Residual ratio : 0.000896532 - Slope : -4.8903 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.9338 - Final Residual ratio : 0.0102336 - Residual ratio : 0.000642257 - Slope : -0.995221 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.8661 - Final Residual ratio : 0.00686934 - Residual ratio : 0.000462082 - Slope : -0.990614 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.129 - Final Residual ratio : 0.0156006 - Residual ratio : 0.000910771 - Slope : -1.22239 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7391 -dimension in distance computation 2 -elements_to_solve.size() : 34 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.7708 - Final Residual ratio : 0.00246326 - Residual ratio : 0.000653247 - Slope : -0.235521 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.6758 - Final Residual ratio : 0.00162883 - Residual ratio : 0.000608726 - Slope : -0.191012 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0292 - Final Residual ratio : 0.0018995 - Residual ratio : 0.00093608 - Slope : -0.155946 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65895 - Final Residual ratio : 0.00111594 - Residual ratio : 0.000672677 - Slope : -0.110522 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.6197 - Final Residual ratio : 0.0162665 - Residual ratio : 0.000978752 - Slope : -1.38362 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7441 -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.10991 - Final Residual ratio : 0.00121777 - Residual ratio : 0.000577164 - Slope : -0.131794 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.57069 - Final Residual ratio : 0.00197894 - Residual ratio : 0.000769812 - Slope : -0.171247 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.81292 - Final Residual ratio : 0.00199122 - Residual ratio : 0.000707883 - Slope : -0.187396 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.82267 - Final Residual ratio : 0.00193776 - Residual ratio : 0.000686498 - Slope : -0.188049 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.60792 - Final Residual ratio : 0.00197016 - Residual ratio : 0.000755451 - Slope : -0.17373 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7491 -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.18851 - Final Residual ratio : 0.00215043 - Residual ratio : 0.000982604 - Slope : -0.182196 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70945 - Final Residual ratio : 0.00146962 - Residual ratio : 0.000859706 - Slope : -0.131383 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30741 - Final Residual ratio : 0.00115579 - Residual ratio : 0.000884029 - Slope : -0.100481 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.23624 - Final Residual ratio : 0.00119781 - Residual ratio : 0.000968917 - Slope : -0.0771899 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52538 - Final Residual ratio : 0.00113482 - Residual ratio : 0.000743957 - Slope : -0.108875 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7541 -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.89696 - Final Residual ratio : 0.00165234 - Residual ratio : 0.000871042 - Slope : -0.126354 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.21485 - Final Residual ratio : 0.0020131 - Residual ratio : 0.000908909 - Slope : -0.15806 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.35838 - Final Residual ratio : 0.00211384 - Residual ratio : 0.000896307 - Slope : -0.168305 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.3131 - Final Residual ratio : 0.00214454 - Residual ratio : 0.000927128 - Slope : -0.165068 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0949 - Final Residual ratio : 0.00194725 - Residual ratio : 0.000929517 - Slope : -0.160997 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7591 -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75612 - Final Residual ratio : 0.00157499 - Residual ratio : 0.00089686 - Slope : -0.146212 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37219 - Final Residual ratio : 0.000951893 - Residual ratio : 0.000693705 - Slope : -0.0979453 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10089 - Final Residual ratio : 0.000990598 - Residual ratio : 0.000899812 - Slope : -0.068744 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10187 - Final Residual ratio : 0.000894928 - Residual ratio : 0.000812186 - Slope : -0.0688112 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32617 - Final Residual ratio : 0.00121466 - Residual ratio : 0.000915916 - Slope : -0.0946396 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7641 -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.58158 - Final Residual ratio : 0.000874044 - Residual ratio : 0.00055264 - Slope : -0.10538 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76265 - Final Residual ratio : 0.00136439 - Residual ratio : 0.000774056 - Slope : -0.117419 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80812 - Final Residual ratio : 0.00114846 - Residual ratio : 0.000635168 - Slope : -0.120465 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70983 - Final Residual ratio : 0.00118249 - Residual ratio : 0.000691584 - Slope : -0.122046 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4892 - Final Residual ratio : 0.00145325 - Residual ratio : 0.000975857 - Slope : -0.114442 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7691 -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14902 - Final Residual ratio : 0.00101113 - Residual ratio : 0.000879993 - Slope : -0.0956673 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.919569 - Final Residual ratio : 0.000773416 - Residual ratio : 0.000841063 - Slope : -0.0656283 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.839535 - Final Residual ratio : 0.000628605 - Residual ratio : 0.000748754 - Slope : -0.0493474 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.989013 - Final Residual ratio : 0.000973755 - Residual ratio : 0.000984573 - Slope : -0.0705742 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2351 - Final Residual ratio : 0.000671831 - Residual ratio : 0.000543949 - Slope : -0.0822953 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7741 -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40511 - Final Residual ratio : 0.00096374 - Residual ratio : 0.000685885 - Slope : -0.0936094 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56866 - Final Residual ratio : 0.00113868 - Residual ratio : 0.000725891 - Slope : -0.111966 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57896 - Final Residual ratio : 0.00124003 - Residual ratio : 0.000785343 - Slope : -0.121363 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47496 - Final Residual ratio : 0.00134071 - Residual ratio : 0.000908982 - Slope : -0.133965 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.28356 - Final Residual ratio : 0.000840986 - Residual ratio : 0.0006552 - Slope : -0.106893 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7791 -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03596 - Final Residual ratio : 0.000706974 - Residual ratio : 0.000682433 - Slope : -0.0796349 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.871426 - Final Residual ratio : 0.000590803 - Residual ratio : 0.000677972 - Slope : -0.0580557 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.822138 - Final Residual ratio : 0.000744493 - Residual ratio : 0.000905557 - Slope : -0.0483173 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 74.1437 - Final Residual ratio : 0.0539946 - Residual ratio : 0.000728243 - Slope : -4.93931 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.3213 - Final Residual ratio : 0.0151932 - Residual ratio : 0.000600015 - Slope : -1.68708 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7841 -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.68579 - Final Residual ratio : 0.00281172 - Residual ratio : 0.000600053 - Slope : -0.292686 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.1374 - Final Residual ratio : 0.015274 - Residual ratio : 0.000490534 - Slope : -1.83071 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.0929 - Final Residual ratio : 0.0183176 - Residual ratio : 0.000868426 - Slope : -1.50533 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.6682 - Final Residual ratio : 0.0105539 - Residual ratio : 0.000633174 - Slope : -1.18983 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.38867 - Final Residual ratio : 0.00114257 - Residual ratio : 0.000478329 - Slope : -0.140443 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7891 -dimension in distance computation 2 -elements_to_solve.size() : 35 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1722 - Final Residual ratio : 0.000999462 - Residual ratio : 0.000852636 - Slope : -0.0732002 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.7779 - Final Residual ratio : 0.0119817 - Residual ratio : 0.00093769 - Slope : -1.16054 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.16554 - Final Residual ratio : 0.000862985 - Residual ratio : 0.000740419 - Slope : -0.0776449 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.46972 - Final Residual ratio : 0.00101731 - Residual ratio : 0.000692183 - Slope : -0.0979132 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.58891 - Final Residual ratio : 0.00101353 - Residual ratio : 0.000637873 - Slope : -0.10586 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7941 -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56016 - Final Residual ratio : 0.000776046 - Residual ratio : 0.000497415 - Slope : -0.103959 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.54488 - Final Residual ratio : 0.000932694 - Residual ratio : 0.000603734 - Slope : -0.10293 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42339 - Final Residual ratio : 0.00111331 - Residual ratio : 0.000782152 - Slope : -0.0948185 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24651 - Final Residual ratio : 0.000648024 - Residual ratio : 0.00051987 - Slope : -0.0830576 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05433 - Final Residual ratio : 0.000866763 - Residual ratio : 0.000822099 - Slope : -0.0752473 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.7991 -dimension in distance computation 2 -elements_to_solve.size() : 36 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.932581 - Final Residual ratio : 0.00052895 - Residual ratio : 0.000567189 - Slope : -0.0621368 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.842244 - Final Residual ratio : 0.000542225 - Residual ratio : 0.000643786 - Slope : -0.0561134 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 82.8522 - Final Residual ratio : 0.0783463 - Residual ratio : 0.000945616 - Slope : -10.3467 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.2526 - Final Residual ratio : 0.0182649 - Residual ratio : 0.000948697 - Slope : -1.74858 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2768 - Final Residual ratio : 0.0138986 - Residual ratio : 0.000853888 - Slope : -1.35524 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8041 -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.67409 - Final Residual ratio : 0.00305079 - Residual ratio : 0.000652701 - Slope : -0.333646 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.24209 - Final Residual ratio : 0.00317148 - Residual ratio : 0.00097822 - Slope : -0.231352 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.97547 - Final Residual ratio : 0.00260283 - Residual ratio : 0.000874761 - Slope : -0.228682 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.76339 - Final Residual ratio : 0.00233661 - Residual ratio : 0.000845558 - Slope : -0.251005 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.5741 - Final Residual ratio : 0.00247099 - Residual ratio : 0.000959945 - Slope : -0.197817 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8091 -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.29899 - Final Residual ratio : 0.00154735 - Residual ratio : 0.000673054 - Slope : -0.164103 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.28035 - Final Residual ratio : 0.00133924 - Residual ratio : 0.000587294 - Slope : -0.162787 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.18106 - Final Residual ratio : 0.00109175 - Residual ratio : 0.00050056 - Slope : -0.155712 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0933 - Final Residual ratio : 0.00124629 - Residual ratio : 0.000595373 - Slope : -0.149433 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00552 - Final Residual ratio : 0.00194325 - Residual ratio : 0.00096895 - Slope : -0.143113 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8141 -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82406 - Final Residual ratio : 0.00153003 - Residual ratio : 0.000838803 - Slope : -0.165684 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80539 - Final Residual ratio : 0.00153066 - Residual ratio : 0.000847827 - Slope : -0.138759 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.5923 - Final Residual ratio : 0.0587584 - Residual ratio : 0.00080943 - Slope : -4.83557 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.0921 - Final Residual ratio : 0.0196295 - Residual ratio : 0.000782298 - Slope : -1.6715 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.9704 - Final Residual ratio : 0.0123699 - Residual ratio : 0.000458649 - Slope : -1.58577 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8191 -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9458 - Final Residual ratio : 0.0185426 - Residual ratio : 0.000929651 - Slope : -1.42337 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.7339 - Final Residual ratio : 0.0114208 - Residual ratio : 0.000682495 - Slope : -1.19447 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.55017 - Final Residual ratio : 0.00179205 - Residual ratio : 0.000702718 - Slope : -0.159273 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50885 - Final Residual ratio : 0.00108079 - Residual ratio : 0.000716298 - Slope : -0.100518 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42267 - Final Residual ratio : 0.00127168 - Residual ratio : 0.000893866 - Slope : -0.101528 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8241 -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31094 - Final Residual ratio : 0.00104757 - Residual ratio : 0.000799099 - Slope : -0.100761 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40029 - Final Residual ratio : 0.000977186 - Residual ratio : 0.000697848 - Slope : -0.0932872 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38704 - Final Residual ratio : 0.00130942 - Residual ratio : 0.000944041 - Slope : -0.0923817 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34991 - Final Residual ratio : 0.000632142 - Residual ratio : 0.000468283 - Slope : -0.0843301 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29317 - Final Residual ratio : 0.00114681 - Residual ratio : 0.000886818 - Slope : -0.0861349 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8291 -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11905 - Final Residual ratio : 0.000654886 - Residual ratio : 0.000585217 - Slope : -0.0745596 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14231 - Final Residual ratio : 0.000872617 - Residual ratio : 0.000763903 - Slope : -0.0760961 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09154 - Final Residual ratio : 0.000809559 - Residual ratio : 0.000741664 - Slope : -0.0681709 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05533 - Final Residual ratio : 0.000643393 - Residual ratio : 0.000609663 - Slope : -0.0659177 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03733 - Final Residual ratio : 0.00103671 - Residual ratio : 0.000999399 - Slope : -0.079715 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8341 -dimension in distance computation 2 -elements_to_solve.size() : 37 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00343 - Final Residual ratio : 0.000846763 - Residual ratio : 0.000843865 - Slope : -0.0626617 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02286 - Final Residual ratio : 0.000663873 - Residual ratio : 0.000649039 - Slope : -0.063887 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.6845 - Final Residual ratio : 0.0115287 - Residual ratio : 0.000908875 - Slope : -1.15209 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.952596 - Final Residual ratio : 0.000465122 - Residual ratio : 0.000488269 - Slope : -0.0634754 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.910805 - Final Residual ratio : 0.000584806 - Residual ratio : 0.000642076 - Slope : -0.0505678 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8391 -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.869598 - Final Residual ratio : 0.000734016 - Residual ratio : 0.000844087 - Slope : -0.054304 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.882434 - Final Residual ratio : 0.000574953 - Residual ratio : 0.000651553 - Slope : -0.0551162 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.88544 - Final Residual ratio : 0.000565471 - Residual ratio : 0.000638632 - Slope : -0.0680673 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.895747 - Final Residual ratio : 0.000657978 - Residual ratio : 0.000734557 - Slope : -0.0559431 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.90302 - Final Residual ratio : 0.000744776 - Residual ratio : 0.000824762 - Slope : -0.0563922 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8441 -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.816263 - Final Residual ratio : 0.000402534 - Residual ratio : 0.000493142 - Slope : -0.0479918 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.858678 - Final Residual ratio : 0.000768592 - Residual ratio : 0.000895088 - Slope : -0.0536193 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.82755 - Final Residual ratio : 0.00049558 - Residual ratio : 0.000598853 - Slope : -0.0486502 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.786642 - Final Residual ratio : 0.000573263 - Residual ratio : 0.000728746 - Slope : -0.0561478 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.753142 - Final Residual ratio : 0.000710184 - Residual ratio : 0.000942962 - Slope : -0.0501621 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8491 -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.703695 - Final Residual ratio : 0.000647103 - Residual ratio : 0.000919579 - Slope : -0.0502177 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.5099 - Final Residual ratio : 0.0600838 - Residual ratio : 0.000828629 - Slope : -4.82999 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.9943 - Final Residual ratio : 0.0204814 - Residual ratio : 0.000819443 - Slope : -1.66492 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.70899 - Final Residual ratio : 0.00274771 - Residual ratio : 0.000583503 - Slope : -0.33616 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.1232 - Final Residual ratio : 0.0153398 - Residual ratio : 0.000492874 - Slope : -1.82987 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8541 -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.7322 - Final Residual ratio : 0.0155964 - Residual ratio : 0.000752279 - Slope : -1.47976 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3007 - Final Residual ratio : 0.010311 - Residual ratio : 0.000632549 - Slope : -1.1636 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.26237 - Final Residual ratio : 0.00221886 - Residual ratio : 0.000980769 - Slope : -0.150676 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11362 - Final Residual ratio : 0.000735703 - Residual ratio : 0.000660639 - Slope : -0.0741925 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12663 - Final Residual ratio : 0.00108577 - Residual ratio : 0.000963735 - Slope : -0.0803957 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8591 -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13065 - Final Residual ratio : 0.000871316 - Residual ratio : 0.000770631 - Slope : -0.0706113 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27475 - Final Residual ratio : 0.000397709 - Residual ratio : 0.000311989 - Slope : -0.074962 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29948 - Final Residual ratio : 0.000441294 - Residual ratio : 0.000339593 - Slope : -0.076414 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26104 - Final Residual ratio : 0.00115889 - Residual ratio : 0.000918992 - Slope : -0.0787427 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17181 - Final Residual ratio : 0.000667273 - Residual ratio : 0.000569436 - Slope : -0.068891 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8641 -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.976368 - Final Residual ratio : 0.000401805 - Residual ratio : 0.00041153 - Slope : -0.0697118 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.915476 - Final Residual ratio : 0.000432254 - Residual ratio : 0.000472163 - Slope : -0.0571903 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.82487 - Final Residual ratio : 0.000383661 - Residual ratio : 0.000465117 - Slope : -0.0515304 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.780489 - Final Residual ratio : 0.000770999 - Residual ratio : 0.00098784 - Slope : -0.0487324 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.785195 - Final Residual ratio : 0.000472165 - Residual ratio : 0.000601335 - Slope : -0.0523149 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8691 -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.785552 - Final Residual ratio : 0.000645069 - Residual ratio : 0.000821167 - Slope : -0.046171 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.841231 - Final Residual ratio : 0.000656538 - Residual ratio : 0.000780449 - Slope : -0.0494455 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.849186 - Final Residual ratio : 0.000595743 - Residual ratio : 0.000701545 - Slope : -0.0499171 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.836326 - Final Residual ratio : 0.000673094 - Residual ratio : 0.000804823 - Slope : -0.0557102 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.812668 - Final Residual ratio : 0.000513612 - Residual ratio : 0.000632008 - Slope : -0.0507596 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8741 -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.672778 - Final Residual ratio : 0.000400192 - Residual ratio : 0.000594835 - Slope : -0.0420236 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.764362 - Final Residual ratio : 0.000620586 - Residual ratio : 0.0008119 - Slope : -0.0477338 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.775971 - Final Residual ratio : 0.000714408 - Residual ratio : 0.000920663 - Slope : -0.0484535 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.0841 - Final Residual ratio : 0.0508107 - Residual ratio : 0.000714797 - Slope : -4.73556 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.4802 - Final Residual ratio : 0.0145926 - Residual ratio : 0.000596099 - Slope : -1.63104 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8791 -dimension in distance computation 2 -elements_to_solve.size() : 38 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.5741 - Final Residual ratio : 0.0122167 - Residual ratio : 0.000459722 - Slope : -1.56246 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.7529 - Final Residual ratio : 0.0113961 - Residual ratio : 0.000576934 - Slope : -1.3161 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.9183 - Final Residual ratio : 0.00975072 - Residual ratio : 0.000515411 - Slope : -1.35061 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.17492 - Final Residual ratio : 0.00130177 - Residual ratio : 0.000598537 - Slope : -0.12786 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.994045 - Final Residual ratio : 0.000594288 - Residual ratio : 0.000597848 - Slope : -0.0620907 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8841 -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.973957 - Final Residual ratio : 0.000490801 - Residual ratio : 0.000503924 - Slope : -0.0608416 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.953483 - Final Residual ratio : 0.000873984 - Residual ratio : 0.000916622 - Slope : -0.0635073 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.964058 - Final Residual ratio : 0.000570466 - Residual ratio : 0.000591734 - Slope : -0.060218 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.954163 - Final Residual ratio : 0.000832648 - Residual ratio : 0.000872647 - Slope : -0.0595832 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.932286 - Final Residual ratio : 0.000493203 - Residual ratio : 0.000529025 - Slope : -0.0665566 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8891 -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.866316 - Final Residual ratio : 0.000547184 - Residual ratio : 0.000631622 - Slope : -0.0618406 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.871069 - Final Residual ratio : 0.000490604 - Residual ratio : 0.000563221 - Slope : -0.0544111 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.863086 - Final Residual ratio : 0.000514731 - Residual ratio : 0.000596385 - Slope : -0.0539107 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.840378 - Final Residual ratio : 0.000772675 - Residual ratio : 0.000919438 - Slope : -0.0559737 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.805148 - Final Residual ratio : 0.000688606 - Residual ratio : 0.000855254 - Slope : -0.0618815 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8941 -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.72202 - Final Residual ratio : 0.000558838 - Residual ratio : 0.000773993 - Slope : -0.0450913 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.711606 - Final Residual ratio : 0.000692891 - Residual ratio : 0.0009737 - Slope : -0.0546856 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.682855 - Final Residual ratio : 0.000441932 - Residual ratio : 0.000647183 - Slope : -0.0487438 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.661294 - Final Residual ratio : 0.000426652 - Residual ratio : 0.000645178 - Slope : -0.0440578 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.652121 - Final Residual ratio : 0.000234133 - Residual ratio : 0.000359033 - Slope : -0.0434591 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.8991 -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 86.0158 - Final Residual ratio : 0.0771548 - Residual ratio : 0.000896983 - Slope : -17.1877 - Tolerance : 0.001 - Number of iterations : 5 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.3569 - Final Residual ratio : 0.0114997 - Residual ratio : 0.000492347 - Slope : -2.33454 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.6997 - Final Residual ratio : 0.0120564 - Residual ratio : 0.000721951 - Slope : -1.51706 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.15412 - Final Residual ratio : 0.00391945 - Residual ratio : 0.000943509 - Slope : -0.34585 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.41665 - Final Residual ratio : 0.00223453 - Residual ratio : 0.00065401 - Slope : -0.262647 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9041 -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.08797 - Final Residual ratio : 0.00276511 - Residual ratio : 0.000895447 - Slope : -0.440743 - Tolerance : 0.001 - Number of iterations : 7 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.94285 - Final Residual ratio : 0.00190057 - Residual ratio : 0.000645828 - Slope : -0.245079 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.75853 - Final Residual ratio : 0.00213766 - Residual ratio : 0.000774925 - Slope : -0.250581 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.59004 - Final Residual ratio : 0.00188255 - Residual ratio : 0.00072684 - Slope : -0.235287 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.43553 - Final Residual ratio : 0.00215229 - Residual ratio : 0.000883706 - Slope : -0.202781 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9091 -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.22552 - Final Residual ratio : 0.00139823 - Residual ratio : 0.000628269 - Slope : -0.171086 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.15408 - Final Residual ratio : 0.00128827 - Residual ratio : 0.000598062 - Slope : -0.15377 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.02909 - Final Residual ratio : 0.00191781 - Residual ratio : 0.000945158 - Slope : -0.155936 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.90869 - Final Residual ratio : 0.00129704 - Residual ratio : 0.000679543 - Slope : -0.146723 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.79606 - Final Residual ratio : 0.00176869 - Residual ratio : 0.000984759 - Slope : -0.163118 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9141 -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65471 - Final Residual ratio : 0.00082422 - Residual ratio : 0.000498105 - Slope : -0.150353 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.2141 - Final Residual ratio : 0.0565692 - Residual ratio : 0.000783353 - Slope : -4.8105 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.7545 - Final Residual ratio : 0.0179032 - Residual ratio : 0.00072323 - Slope : -1.6491 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.8001 - Final Residual ratio : 0.0123475 - Residual ratio : 0.000460726 - Slope : -1.57575 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9144 - Final Residual ratio : 0.0108631 - Residual ratio : 0.000545489 - Slope : -1.3269 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9191 -dimension in distance computation 2 -elements_to_solve.size() : 39 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5414 - Final Residual ratio : 0.0102956 - Residual ratio : 0.000622411 - Slope : -1.18079 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.47596 - Final Residual ratio : 0.00153872 - Residual ratio : 0.000621466 - Slope : -0.154651 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37059 - Final Residual ratio : 0.00125989 - Residual ratio : 0.000919231 - Slope : -0.0978091 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26792 - Final Residual ratio : 0.000991885 - Residual ratio : 0.000782293 - Slope : -0.097456 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26251 - Final Residual ratio : 0.000220999 - Residual ratio : 0.000175047 - Slope : -0.0788932 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9241 -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.96008 - Final Residual ratio : 0.00441626 - Residual ratio : 0.000554801 - Slope : -0.662972 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37506 - Final Residual ratio : 0.000881749 - Residual ratio : 0.000641246 - Slope : -0.0981553 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12451 - Final Residual ratio : 0.000924136 - Residual ratio : 0.000821811 - Slope : -0.0749059 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09989 - Final Residual ratio : 0.000846709 - Residual ratio : 0.00076981 - Slope : -0.0732698 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0306 - Final Residual ratio : 0.00103047 - Residual ratio : 0.000999869 - Slope : -0.0686382 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9291 -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.920076 - Final Residual ratio : 0.000536489 - Residual ratio : 0.000583092 - Slope : -0.0613027 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.871721 - Final Residual ratio : 0.000720199 - Residual ratio : 0.00082618 - Slope : -0.0580667 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.825365 - Final Residual ratio : 0.000739395 - Residual ratio : 0.00089584 - Slope : -0.054975 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.798734 - Final Residual ratio : 0.000702999 - Residual ratio : 0.000880142 - Slope : -0.0570022 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.788613 - Final Residual ratio : 0.000483346 - Residual ratio : 0.000612906 - Slope : -0.0492581 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9341 -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.787022 - Final Residual ratio : 0.000780991 - Residual ratio : 0.000992337 - Slope : -0.0491401 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.774292 - Final Residual ratio : 0.000399025 - Residual ratio : 0.000515341 - Slope : -0.0483683 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.753387 - Final Residual ratio : 0.000448747 - Residual ratio : 0.000595639 - Slope : -0.0501959 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.724537 - Final Residual ratio : 0.000614142 - Residual ratio : 0.000847633 - Slope : -0.0482615 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.69754 - Final Residual ratio : 0.000682563 - Residual ratio : 0.000978529 - Slope : -0.0464572 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9391 -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.619194 - Final Residual ratio : 0.000595151 - Residual ratio : 0.000961171 - Slope : -0.0412399 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.667273 - Final Residual ratio : 0.000473463 - Residual ratio : 0.00070955 - Slope : -0.0476285 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.681601 - Final Residual ratio : 0.000489713 - Residual ratio : 0.000718475 - Slope : -0.0425695 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.688808 - Final Residual ratio : 0.000594008 - Residual ratio : 0.000862371 - Slope : -0.0430134 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.685522 - Final Residual ratio : 0.000564599 - Residual ratio : 0.000823605 - Slope : -0.0428098 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9441 -dimension in distance computation 2 -elements_to_solve.size() : 41 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.594756 - Final Residual ratio : 0.000358804 - Residual ratio : 0.00060328 - Slope : -0.0371498 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.635694 - Final Residual ratio : 0.00017849 - Residual ratio : 0.00028078 - Slope : -0.0353064 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.614061 - Final Residual ratio : 0.000314124 - Residual ratio : 0.000511551 - Slope : -0.043839 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.1836 - Final Residual ratio : 0.0344238 - Residual ratio : 0.000901532 - Slope : -3.46811 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.885 - Final Residual ratio : 0.00529199 - Residual ratio : 0.000671147 - Slope : -0.606131 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9491 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.88253 - Final Residual ratio : 0.00441638 - Residual ratio : 0.000641679 - Slope : -0.573176 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.87538 - Final Residual ratio : 0.0015013 - Residual ratio : 0.000522121 - Slope : -0.221068 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.57001 - Final Residual ratio : 0.00350486 - Residual ratio : 0.00098175 - Slope : -0.297209 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.5549 - Final Residual ratio : 0.0120456 - Residual ratio : 0.0008276 - Slope : -1.2119 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.4001 - Final Residual ratio : 0.027766 - Residual ratio : 0.000856973 - Slope : -4.62462 - Tolerance : 0.001 - Number of iterations : 7 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9541 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 80.3102 - Final Residual ratio : 0.0515234 - Residual ratio : 0.000641555 - Slope : -5.35058 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.0251 - Final Residual ratio : 0.0173301 - Residual ratio : 0.000692509 - Slope : -1.66719 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.31874 - Final Residual ratio : 0.00440345 - Residual ratio : 0.000696888 - Slope : -0.574031 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.49667 - Final Residual ratio : 0.0037023 - Residual ratio : 0.000673553 - Slope : -0.366198 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.8188 - Final Residual ratio : 0.014843 - Residual ratio : 0.000481621 - Slope : -1.812 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9591 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.3687 - Final Residual ratio : 0.0179717 - Residual ratio : 0.000882316 - Slope : -1.45363 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.9031 - Final Residual ratio : 0.0147402 - Residual ratio : 0.000926877 - Slope : -1.13488 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.67608 - Final Residual ratio : 0.00219477 - Residual ratio : 0.000820143 - Slope : -0.167118 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.20687 - Final Residual ratio : 0.00208385 - Residual ratio : 0.000944257 - Slope : -0.157484 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.59208 - Final Residual ratio : 0.00150172 - Residual ratio : 0.000579348 - Slope : -0.172705 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9641 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.8559 - Final Residual ratio : 0.00216244 - Residual ratio : 0.000757184 - Slope : -0.190249 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.02844 - Final Residual ratio : 0.00276775 - Residual ratio : 0.00091392 - Slope : -0.201712 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.97782 - Final Residual ratio : 0.0024122 - Residual ratio : 0.000810056 - Slope : -0.19836 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.75931 - Final Residual ratio : 0.00195941 - Residual ratio : 0.00071011 - Slope : -0.172334 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.42411 - Final Residual ratio : 0.000772485 - Residual ratio : 0.000318667 - Slope : -0.173096 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9691 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00397 - Final Residual ratio : 0.00124033 - Residual ratio : 0.000618934 - Slope : -0.133515 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70905 - Final Residual ratio : 0.0009146 - Residual ratio : 0.000535149 - Slope : -0.113876 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.98497 - Final Residual ratio : 0.00295413 - Residual ratio : 0.000741317 - Slope : -0.306309 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51107 - Final Residual ratio : 0.00130102 - Residual ratio : 0.000860993 - Slope : -0.0943603 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82036 - Final Residual ratio : 0.00124696 - Residual ratio : 0.000685007 - Slope : -0.113695 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9741 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.93369 - Final Residual ratio : 0.000808394 - Residual ratio : 0.000418059 - Slope : -0.113699 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.94837 - Final Residual ratio : 0.00110722 - Residual ratio : 0.000568277 - Slope : -0.177024 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.88416 - Final Residual ratio : 0.000868576 - Residual ratio : 0.000460988 - Slope : -0.117706 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.73428 - Final Residual ratio : 0.00157095 - Residual ratio : 0.000905821 - Slope : -0.115514 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 81.7786 - Final Residual ratio : 0.0766519 - Residual ratio : 0.00093731 - Slope : -20.4255 - Tolerance : 0.001 - Number of iterations : 4 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9791 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.1727 - Final Residual ratio : 0.00890654 - Residual ratio : 0.000401689 - Slope : -2.21638 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.796 - Final Residual ratio : 0.0107235 - Residual ratio : 0.000909082 - Slope : -1.07139 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.7921 - Final Residual ratio : 0.00372897 - Residual ratio : 0.000983353 - Slope : -0.291413 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 70.1932 - Final Residual ratio : 0.0531535 - Residual ratio : 0.000757245 - Slope : -4.676 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.4279 - Final Residual ratio : 0.017189 - Residual ratio : 0.000703661 - Slope : -1.62738 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9841 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.35682 - Final Residual ratio : 0.00239427 - Residual ratio : 0.000446958 - Slope : -0.334652 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.74463 - Final Residual ratio : 0.00387969 - Residual ratio : 0.000817702 - Slope : -0.31605 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.951 - Final Residual ratio : 0.0296196 - Residual ratio : 0.000988937 - Slope : -1.87008 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.0558 - Final Residual ratio : 0.0133609 - Residual ratio : 0.000666189 - Slope : -1.4316 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.7922 - Final Residual ratio : 0.00866346 - Residual ratio : 0.000548591 - Slope : -1.1274 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9891 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.91874 - Final Residual ratio : 0.00259601 - Residual ratio : 0.00088943 - Slope : -0.182259 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03597 - Final Residual ratio : 0.00130009 - Residual ratio : 0.000638562 - Slope : -0.135645 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.94527 - Final Residual ratio : 0.00146979 - Residual ratio : 0.000755572 - Slope : -0.129587 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.93277 - Final Residual ratio : 0.00180052 - Residual ratio : 0.000931578 - Slope : -0.128731 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.92054 - Final Residual ratio : 0.00109042 - Residual ratio : 0.000567769 - Slope : -0.119965 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9941 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80926 - Final Residual ratio : 0.00114342 - Residual ratio : 0.000631983 - Slope : -0.113007 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.78726 - Final Residual ratio : 0.00120981 - Residual ratio : 0.000676909 - Slope : -0.111628 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67061 - Final Residual ratio : 0.00111728 - Residual ratio : 0.000668783 - Slope : -0.104343 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.511 - Final Residual ratio : 0.00128185 - Residual ratio : 0.000848346 - Slope : -0.100648 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33274 - Final Residual ratio : 0.00100526 - Residual ratio : 0.000754278 - Slope : -0.0887822 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 0.9991 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12056 - Final Residual ratio : 0.000612111 - Residual ratio : 0.000546254 - Slope : -0.0746633 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05618 - Final Residual ratio : 0.000783073 - Residual ratio : 0.000741421 - Slope : -0.0703597 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -writing a 2D mesh -0.001 -******** CURRENT TIME = 1.0011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03111 - Final Residual ratio : 0.000640058 - Residual ratio : 0.000620746 - Slope : -0.079267 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06291 - Final Residual ratio : 0.00100925 - Residual ratio : 0.000949519 - Slope : -0.0707933 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11602 - Final Residual ratio : 0.000731746 - Residual ratio : 0.000655672 - Slope : -0.0697058 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0041 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14922 - Final Residual ratio : 0.000814733 - Residual ratio : 0.000708946 - Slope : -0.0717752 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1522 - Final Residual ratio : 0.000771894 - Residual ratio : 0.000669928 - Slope : -0.0719645 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11328 - Final Residual ratio : 0.000709439 - Residual ratio : 0.000637251 - Slope : -0.0695357 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04213 - Final Residual ratio : 0.000588968 - Residual ratio : 0.00056516 - Slope : -0.0694359 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.961099 - Final Residual ratio : 0.000683512 - Residual ratio : 0.000711178 - Slope : -0.0640277 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0091 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.0044 - Final Residual ratio : 0.0473103 - Residual ratio : 0.000657047 - Slope : -4.79714 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 46.9775 - Final Residual ratio : 0.0210778 - Residual ratio : 0.000448679 - Slope : -3.35403 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.1565 - Final Residual ratio : 0.0324646 - Residual ratio : 0.000752252 - Slope : -4.79156 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.0539 - Final Residual ratio : 0.0146217 - Residual ratio : 0.000486515 - Slope : -1.76702 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.171 - Final Residual ratio : 0.0115378 - Residual ratio : 0.000571997 - Slope : -1.34397 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0141 -dimension in distance computation 2 -elements_to_solve.size() : 42 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.1254 - Final Residual ratio : 0.0136778 - Residual ratio : 0.00084821 - Slope : -1.15084 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.58354 - Final Residual ratio : 0.00138176 - Residual ratio : 0.000534833 - Slope : -0.161385 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.56766 - Final Residual ratio : 0.00179624 - Residual ratio : 0.000699565 - Slope : -0.183276 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63154 - Final Residual ratio : 0.00162017 - Residual ratio : 0.000993029 - Slope : -0.116423 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83129 - Final Residual ratio : 0.00161348 - Residual ratio : 0.000881064 - Slope : -0.203297 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0191 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84296 - Final Residual ratio : 0.00131055 - Residual ratio : 0.000711109 - Slope : -0.153471 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.78355 - Final Residual ratio : 0.00148262 - Residual ratio : 0.000831272 - Slope : -0.0990039 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7325 - Final Residual ratio : 0.000887704 - Residual ratio : 0.000512385 - Slope : -0.101859 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67223 - Final Residual ratio : 0.000771624 - Residual ratio : 0.000461434 - Slope : -0.0983212 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61088 - Final Residual ratio : 0.00085508 - Residual ratio : 0.000530814 - Slope : -0.0947075 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0241 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.54767 - Final Residual ratio : 0.0007058 - Residual ratio : 0.000456041 - Slope : -0.154696 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48734 - Final Residual ratio : 0.00146346 - Residual ratio : 0.000983945 - Slope : -0.148588 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43309 - Final Residual ratio : 0.000857962 - Residual ratio : 0.000598681 - Slope : -0.110171 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37727 - Final Residual ratio : 0.000900848 - Residual ratio : 0.000654082 - Slope : -0.0983122 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32339 - Final Residual ratio : 0.00110109 - Residual ratio : 0.000832022 - Slope : -0.0944493 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0291 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27007 - Final Residual ratio : 0.000999515 - Residual ratio : 0.000786977 - Slope : -0.0906479 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.22878 - Final Residual ratio : 0.000585631 - Residual ratio : 0.000476594 - Slope : -0.0818798 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19705 - Final Residual ratio : 0.000831431 - Residual ratio : 0.000694566 - Slope : -0.079748 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17047 - Final Residual ratio : 0.000908671 - Residual ratio : 0.000776329 - Slope : -0.0835402 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14771 - Final Residual ratio : 0.00109572 - Residual ratio : 0.000954697 - Slope : -0.127402 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0341 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10835 - Final Residual ratio : 0.000699529 - Residual ratio : 0.000631145 - Slope : -0.110765 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0957 - Final Residual ratio : 0.000645166 - Residual ratio : 0.000588815 - Slope : -0.0684411 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07028 - Final Residual ratio : 0.000940143 - Residual ratio : 0.000878409 - Slope : -0.0712893 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03965 - Final Residual ratio : 0.000595007 - Residual ratio : 0.000572312 - Slope : -0.0692707 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.009 - Final Residual ratio : 0.000492818 - Residual ratio : 0.000488421 - Slope : -0.0720363 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0391 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.94748 - Final Residual ratio : 0.000874685 - Residual ratio : 0.000923169 - Slope : -0.0676147 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.959367 - Final Residual ratio : 0.000803357 - Residual ratio : 0.000837383 - Slope : -0.0684688 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.952854 - Final Residual ratio : 0.000928511 - Residual ratio : 0.000974453 - Slope : -0.0793271 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.949044 - Final Residual ratio : 0.000342764 - Residual ratio : 0.000361168 - Slope : -0.105411 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 70.5466 - Final Residual ratio : 0.056795 - Residual ratio : 0.000805071 - Slope : -4.69932 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0441 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.2977 - Final Residual ratio : 0.0186489 - Residual ratio : 0.000767517 - Slope : -1.61861 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.69305 - Final Residual ratio : 0.00415404 - Residual ratio : 0.000885148 - Slope : -0.312593 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.93284 - Final Residual ratio : 0.00257806 - Residual ratio : 0.000655521 - Slope : -0.245641 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.7879 - Final Residual ratio : 0.0143486 - Residual ratio : 0.000481691 - Slope : -1.75139 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9971 - Final Residual ratio : 0.0164933 - Residual ratio : 0.000824787 - Slope : -1.42718 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0491 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.6309 - Final Residual ratio : 0.0109813 - Residual ratio : 0.000702537 - Slope : -1.11571 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.22693 - Final Residual ratio : 0.00157773 - Residual ratio : 0.000708477 - Slope : -0.148357 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2808 - Final Residual ratio : 0.00114241 - Residual ratio : 0.000891949 - Slope : -0.0853104 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33884 - Final Residual ratio : 0.000638538 - Residual ratio : 0.000476935 - Slope : -0.0892133 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42999 - Final Residual ratio : 0.000767356 - Residual ratio : 0.000536616 - Slope : -0.0893265 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0541 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40218 - Final Residual ratio : 0.000890051 - Residual ratio : 0.000634764 - Slope : -0.0875803 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4337 - Final Residual ratio : 0.0010181 - Residual ratio : 0.000710122 - Slope : -0.0895424 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37002 - Final Residual ratio : 0.000912744 - Residual ratio : 0.000666228 - Slope : -0.085569 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.25979 - Final Residual ratio : 0.000867285 - Residual ratio : 0.000688437 - Slope : -0.0839282 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12733 - Final Residual ratio : 0.000317799 - Residual ratio : 0.000281903 - Slope : -0.0662951 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0591 -dimension in distance computation 2 -elements_to_solve.size() : 43 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.955379 - Final Residual ratio : 0.000597532 - Residual ratio : 0.00062544 - Slope : -0.0596738 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.902013 - Final Residual ratio : 0.00080983 - Residual ratio : 0.000897803 - Slope : -0.0600802 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31477 - Final Residual ratio : 0.00121861 - Residual ratio : 0.000926862 - Slope : -0.101042 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.809071 - Final Residual ratio : 0.000395481 - Residual ratio : 0.00048881 - Slope : -0.0475691 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18769 - Final Residual ratio : 0.000909953 - Residual ratio : 0.000766154 - Slope : -0.0741738 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0641 -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.28774 - Final Residual ratio : 0.000701769 - Residual ratio : 0.000544964 - Slope : -0.0804396 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.16375 - Final Residual ratio : 0.001026 - Residual ratio : 0.000881631 - Slope : -0.0775147 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.111 - Final Residual ratio : 0.00104234 - Residual ratio : 0.000938201 - Slope : -0.0792825 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04533 - Final Residual ratio : 0.000599783 - Residual ratio : 0.000573772 - Slope : -0.0652958 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.981765 - Final Residual ratio : 0.000980129 - Residual ratio : 0.000998333 - Slope : -0.0653857 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0691 -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.95954 - Final Residual ratio : 0.000821015 - Residual ratio : 0.000855634 - Slope : -0.0737476 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 68.8803 - Final Residual ratio : 0.0495062 - Residual ratio : 0.000718729 - Slope : -4.58872 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.0645 - Final Residual ratio : 0.0142102 - Residual ratio : 0.000590505 - Slope : -1.60335 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.7003 - Final Residual ratio : 0.00446312 - Residual ratio : 0.000949541 - Slope : -0.335417 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.96353 - Final Residual ratio : 0.00378996 - Residual ratio : 0.000956208 - Slope : -0.247484 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0741 -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.4327 - Final Residual ratio : 0.014162 - Residual ratio : 0.000481165 - Slope : -1.7305 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.8139 - Final Residual ratio : 0.0151774 - Residual ratio : 0.000765996 - Slope : -1.4142 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.5849 - Final Residual ratio : 0.00822438 - Residual ratio : 0.000527716 - Slope : -1.11262 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.108 - Final Residual ratio : 0.00177556 - Residual ratio : 0.0008423 - Slope : -0.131639 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12197 - Final Residual ratio : 0.000942143 - Residual ratio : 0.00083972 - Slope : -0.0800736 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0791 -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17302 - Final Residual ratio : 0.00055099 - Residual ratio : 0.000469721 - Slope : -0.0781643 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24393 - Final Residual ratio : 0.000849192 - Residual ratio : 0.000682667 - Slope : -0.0887917 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27334 - Final Residual ratio : 0.00064285 - Residual ratio : 0.000504854 - Slope : -0.0848463 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24893 - Final Residual ratio : 0.000974641 - Residual ratio : 0.000780381 - Slope : -0.083197 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18475 - Final Residual ratio : 0.000643133 - Residual ratio : 0.000542841 - Slope : -0.074007 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0841 -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02109 - Final Residual ratio : 0.000752867 - Residual ratio : 0.000737318 - Slope : -0.0680224 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.972107 - Final Residual ratio : 0.000605192 - Residual ratio : 0.000622557 - Slope : -0.0607189 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.87645 - Final Residual ratio : 0.000628093 - Residual ratio : 0.000716633 - Slope : -0.0547388 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.784826 - Final Residual ratio : 0.000467264 - Residual ratio : 0.000595372 - Slope : -0.0490224 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.715153 - Final Residual ratio : 0.000625016 - Residual ratio : 0.000873961 - Slope : -0.0510377 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0891 -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.619819 - Final Residual ratio : 0.000517879 - Residual ratio : 0.000835533 - Slope : -0.0412868 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.654991 - Final Residual ratio : 0.000365504 - Residual ratio : 0.000558029 - Slope : -0.0436417 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.657816 - Final Residual ratio : 0.000385226 - Residual ratio : 0.000585613 - Slope : -0.0438287 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.657699 - Final Residual ratio : 0.000393257 - Residual ratio : 0.000597929 - Slope : -0.0438204 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.64995 - Final Residual ratio : 0.000330904 - Residual ratio : 0.000509122 - Slope : -0.043308 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0941 -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.58146 - Final Residual ratio : 0.000454569 - Residual ratio : 0.000781771 - Slope : -0.0387337 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.609 - Final Residual ratio : 0.000592135 - Residual ratio : 0.000972307 - Slope : -0.0380255 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 68.2128 - Final Residual ratio : 0.0533424 - Residual ratio : 0.000781999 - Slope : -4.54396 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.0508 - Final Residual ratio : 0.0167933 - Residual ratio : 0.000698244 - Slope : -1.60227 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.65837 - Final Residual ratio : 0.00446253 - Residual ratio : 0.000957959 - Slope : -0.423083 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.0991 -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.75811 - Final Residual ratio : 0.00331968 - Residual ratio : 0.000883337 - Slope : -0.234674 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.35918 - Final Residual ratio : 0.00278197 - Residual ratio : 0.000638186 - Slope : -0.272275 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.8853 - Final Residual ratio : 0.0130531 - Residual ratio : 0.000468098 - Slope : -1.63954 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.0189 - Final Residual ratio : 0.0152633 - Residual ratio : 0.000802537 - Slope : -1.3574 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.1651 - Final Residual ratio : 0.0104943 - Residual ratio : 0.000691999 - Slope : -1.08247 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1041 -dimension in distance computation 2 -elements_to_solve.size() : 44 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.1392 - Final Residual ratio : 0.00152201 - Residual ratio : 0.000711482 - Slope : -0.133605 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27914 - Final Residual ratio : 0.000764093 - Residual ratio : 0.00059735 - Slope : -0.0913124 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56688 - Final Residual ratio : 0.00134288 - Residual ratio : 0.000857043 - Slope : -0.111824 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42081 - Final Residual ratio : 0.000935859 - Residual ratio : 0.00065868 - Slope : -0.0887421 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.7567 - Final Residual ratio : 0.0211783 - Residual ratio : 0.000666893 - Slope : -2.1157 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1091 -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.20879 - Final Residual ratio : 0.00157586 - Residual ratio : 0.000491109 - Slope : -0.18866 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.01352 - Final Residual ratio : 0.00162922 - Residual ratio : 0.000809137 - Slope : -0.201189 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8638 - Final Residual ratio : 0.00157011 - Residual ratio : 0.000842422 - Slope : -0.116389 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83946 - Final Residual ratio : 0.00108119 - Residual ratio : 0.000587776 - Slope : -0.122559 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8089 - Final Residual ratio : 0.00120527 - Residual ratio : 0.0006663 - Slope : -0.106335 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1141 -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.71918 - Final Residual ratio : 0.00139834 - Residual ratio : 0.000813375 - Slope : -0.101046 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.54048 - Final Residual ratio : 0.00141704 - Residual ratio : 0.000919871 - Slope : -0.102604 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34934 - Final Residual ratio : 0.000912708 - Residual ratio : 0.000676409 - Slope : -0.0793195 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18158 - Final Residual ratio : 0.000531923 - Residual ratio : 0.000450179 - Slope : -0.0787366 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09529 - Final Residual ratio : 0.000634179 - Residual ratio : 0.000579005 - Slope : -0.0643916 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1191 -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08987 - Final Residual ratio : 0.000744249 - Residual ratio : 0.00068288 - Slope : -0.0573222 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1356 - Final Residual ratio : 0.0011164 - Residual ratio : 0.000983099 - Slope : -0.09454 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 70.1442 - Final Residual ratio : 0.0488191 - Residual ratio : 0.000695981 - Slope : -4.67303 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.6052 - Final Residual ratio : 0.0417671 - Residual ratio : 0.000825351 - Slope : -3.61168 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 90.8545 - Final Residual ratio : 0.0798545 - Residual ratio : 0.000878927 - Slope : -11.3468 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1241 -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.9098 - Final Residual ratio : 0.0380936 - Residual ratio : 0.000693749 - Slope : -4.57264 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 37.6603 - Final Residual ratio : 0.0337356 - Residual ratio : 0.000895788 - Slope : -2.35166 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 23.797 - Final Residual ratio : 0.0126915 - Residual ratio : 0.000533324 - Slope : -1.69888 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9939 - Final Residual ratio : 0.00962108 - Residual ratio : 0.000481201 - Slope : -1.33228 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.41314 - Final Residual ratio : 0.00806248 - Residual ratio : 0.00095832 - Slope : -0.646545 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1291 -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.32144 - Final Residual ratio : 0.0052875 - Residual ratio : 0.000722195 - Slope : -0.522582 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.65483 - Final Residual ratio : 0.0041718 - Residual ratio : 0.000626883 - Slope : -0.511589 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.02519 - Final Residual ratio : 0.00600416 - Residual ratio : 0.00099651 - Slope : -0.501599 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.44031 - Final Residual ratio : 0.00290484 - Residual ratio : 0.000533948 - Slope : -0.388386 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.8981 - Final Residual ratio : 0.00403887 - Residual ratio : 0.000824579 - Slope : -0.349576 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1341 -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.35182 - Final Residual ratio : 0.00316073 - Residual ratio : 0.000726301 - Slope : -0.271791 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.94638 - Final Residual ratio : 0.00258455 - Residual ratio : 0.000654918 - Slope : -0.26292 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 60.9124 - Final Residual ratio : 0.057979 - Residual ratio : 0.000951843 - Slope : -8.69348 - Tolerance : 0.001 - Number of iterations : 7 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 87.3638 - Final Residual ratio : 0.0781086 - Residual ratio : 0.000894061 - Slope : -12.4694 - Tolerance : 0.001 - Number of iterations : 7 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.1487 - Final Residual ratio : 0.0118167 - Residual ratio : 0.000391947 - Slope : -3.01369 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1391 -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.2488 - Final Residual ratio : 0.0131766 - Residual ratio : 0.000924757 - Slope : -1.42356 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.7948 - Final Residual ratio : 0.00376853 - Residual ratio : 0.000554619 - Slope : -0.565919 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.23262 - Final Residual ratio : 0.003749 - Residual ratio : 0.000601513 - Slope : -0.519072 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.61933 - Final Residual ratio : 0.00354562 - Residual ratio : 0.000630969 - Slope : -0.802255 - Tolerance : 0.001 - Number of iterations : 7 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.06189 - Final Residual ratio : 0.00196675 - Residual ratio : 0.00038854 - Slope : -0.42166 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1441 -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.50869 - Final Residual ratio : 0.00280455 - Residual ratio : 0.000622033 - Slope : -0.37549 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.1275 - Final Residual ratio : 0.00253463 - Residual ratio : 0.000614085 - Slope : -0.317305 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.7845 - Final Residual ratio : 0.0553317 - Residual ratio : 0.000792893 - Slope : -4.64861 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.9818 - Final Residual ratio : 0.0200373 - Residual ratio : 0.000668316 - Slope : -1.99745 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.02066 - Final Residual ratio : 0.00391657 - Residual ratio : 0.000650521 - Slope : -0.376047 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1491 -dimension in distance computation 2 -elements_to_solve.size() : 45 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.45827 - Final Residual ratio : 0.00507029 - Residual ratio : 0.000928919 - Slope : -0.340825 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.7928 - Final Residual ratio : 0.0155004 - Residual ratio : 0.000472675 - Slope : -1.92808 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 54.2994 - Final Residual ratio : 0.0189733 - Residual ratio : 0.00034942 - Slope : -3.87717 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 77.1898 - Final Residual ratio : 0.0720091 - Residual ratio : 0.000932884 - Slope : -6.42648 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.7528 - Final Residual ratio : 0.0219197 - Residual ratio : 0.000819343 - Slope : -2.67309 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1541 -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.0837 - Final Residual ratio : 0.00312464 - Residual ratio : 0.000258584 - Slope : -0.929273 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.72488 - Final Residual ratio : 0.00324257 - Residual ratio : 0.0005664 - Slope : -0.440126 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.31777 - Final Residual ratio : 0.00437322 - Residual ratio : 0.000822378 - Slope : -0.408723 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.83415 - Final Residual ratio : 0.00263247 - Residual ratio : 0.000544557 - Slope : -0.345108 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.36713 - Final Residual ratio : 0.0027458 - Residual ratio : 0.000628742 - Slope : -0.311742 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1591 -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.89205 - Final Residual ratio : 0.00216165 - Residual ratio : 0.000555402 - Slope : -0.277849 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.5269 - Final Residual ratio : 0.00346345 - Residual ratio : 0.00098201 - Slope : -0.352343 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.17367 - Final Residual ratio : 0.00212081 - Residual ratio : 0.000668253 - Slope : -0.226539 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.86257 - Final Residual ratio : 0.00258374 - Residual ratio : 0.000902596 - Slope : -0.238332 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.1637 - Final Residual ratio : 0.0443422 - Residual ratio : 0.000883951 - Slope : -7.1599 - Tolerance : 0.001 - Number of iterations : 7 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1641 -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 72.0422 - Final Residual ratio : 0.0657403 - Residual ratio : 0.000912525 - Slope : -11.9961 - Tolerance : 0.001 - Number of iterations : 6 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.1354 - Final Residual ratio : 0.0176597 - Residual ratio : 0.000797802 - Slope : -2.0107 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.7972 - Final Residual ratio : 0.00546449 - Residual ratio : 0.000506104 - Slope : -0.830132 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.78195 - Final Residual ratio : 0.00437178 - Residual ratio : 0.000914225 - Slope : -0.398131 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.37637 - Final Residual ratio : 0.00406793 - Residual ratio : 0.00092952 - Slope : -0.364359 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1691 -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.90359 - Final Residual ratio : 0.00270485 - Residual ratio : 0.000692912 - Slope : -0.300068 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.56721 - Final Residual ratio : 0.00277289 - Residual ratio : 0.000777326 - Slope : -0.254603 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.4114 - Final Residual ratio : 0.0535462 - Residual ratio : 0.000771433 - Slope : -4.62386 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.0432 - Final Residual ratio : 0.0205382 - Residual ratio : 0.000683623 - Slope : -2.00151 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.84342 - Final Residual ratio : 0.00316521 - Residual ratio : 0.000541672 - Slope : -0.365016 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1741 -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.259 - Final Residual ratio : 0.00388137 - Residual ratio : 0.000738043 - Slope : -0.328445 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.2131 - Final Residual ratio : 0.015626 - Residual ratio : 0.000485082 - Slope : -1.89397 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 50.2142 - Final Residual ratio : 0.0174451 - Residual ratio : 0.000347414 - Slope : -3.58548 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.241 - Final Residual ratio : 0.0651333 - Residual ratio : 0.000940676 - Slope : -6.28872 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.5715 - Final Residual ratio : 0.017816 - Residual ratio : 0.000825906 - Slope : -1.95942 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1791 -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.1074 - Final Residual ratio : 0.00397988 - Residual ratio : 0.000393757 - Slope : -0.777189 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.61621 - Final Residual ratio : 0.00370022 - Residual ratio : 0.00080157 - Slope : -0.354808 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.29299 - Final Residual ratio : 0.00354267 - Residual ratio : 0.000825224 - Slope : -0.306389 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.91015 - Final Residual ratio : 0.00303335 - Residual ratio : 0.000775764 - Slope : -0.260474 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.53327 - Final Residual ratio : 0.00351153 - Residual ratio : 0.000993847 - Slope : -0.294146 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1841 -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.11971 - Final Residual ratio : 0.00273197 - Residual ratio : 0.000875712 - Slope : -0.207799 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84884 - Final Residual ratio : 0.00172731 - Residual ratio : 0.000606322 - Slope : -0.203365 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.56708 - Final Residual ratio : 0.00247485 - Residual ratio : 0.000964072 - Slope : -0.213717 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.32825 - Final Residual ratio : 0.00169756 - Residual ratio : 0.000729115 - Slope : -0.193879 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 44.6052 - Final Residual ratio : 0.03871 - Residual ratio : 0.000867837 - Slope : -5.57081 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1891 -dimension in distance computation 2 -elements_to_solve.size() : 46 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.7745 - Final Residual ratio : 0.0522107 - Residual ratio : 0.000806037 - Slope : -10.787 - Tolerance : 0.001 - Number of iterations : 6 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.7226 - Final Residual ratio : 0.0168627 - Residual ratio : 0.000854995 - Slope : -1.97057 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.52346 - Final Residual ratio : 0.0077583 - Residual ratio : 0.000814651 - Slope : -0.95157 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.0959 - Final Residual ratio : 0.00393064 - Residual ratio : 0.000959653 - Slope : -0.409197 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.75571 - Final Residual ratio : 0.00184835 - Residual ratio : 0.000492144 - Slope : -0.375386 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1941 -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.64654 - Final Residual ratio : 0.00308601 - Residual ratio : 0.000546531 - Slope : -0.434112 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.16084 - Final Residual ratio : 0.00172187 - Residual ratio : 0.00054475 - Slope : -0.243009 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.2099 - Final Residual ratio : 0.0531732 - Residual ratio : 0.000768289 - Slope : -4.61045 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.9467 - Final Residual ratio : 0.0197603 - Residual ratio : 0.000659847 - Slope : -1.99513 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.77344 - Final Residual ratio : 0.00323227 - Residual ratio : 0.000559851 - Slope : -0.360638 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.1991 -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.10573 - Final Residual ratio : 0.00469569 - Residual ratio : 0.00091969 - Slope : -0.318815 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 53.4729 - Final Residual ratio : 0.0403024 - Residual ratio : 0.000753699 - Slope : -3.56217 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.0491 - Final Residual ratio : 0.0557716 - Residual ratio : 0.000844397 - Slope : -5.07641 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.027 - Final Residual ratio : 0.0150763 - Residual ratio : 0.000579257 - Slope : -1.858 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 9.44243 - Final Residual ratio : 0.00552778 - Residual ratio : 0.000585419 - Slope : -0.725916 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2041 -dimension in distance computation 2 -elements_to_solve.size() : 47 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.12263 - Final Residual ratio : 0.00257131 - Residual ratio : 0.000623705 - Slope : -0.29429 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.86718 - Final Residual ratio : 0.00208955 - Residual ratio : 0.000540329 - Slope : -0.297314 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.57045 - Final Residual ratio : 0.00213708 - Residual ratio : 0.000598548 - Slope : -0.254879 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 49.823 - Final Residual ratio : 0.0486181 - Residual ratio : 0.000975816 - Slope : -6.2218 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.3058 - Final Residual ratio : 0.00929279 - Residual ratio : 0.000755155 - Slope : -0.945886 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2091 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 11.415 - Final Residual ratio : 0.00869368 - Residual ratio : 0.000761604 - Slope : -1.26736 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 44.589 - Final Residual ratio : 0.0267419 - Residual ratio : 0.000599742 - Slope : -6.36604 - Tolerance : 0.001 - Number of iterations : 7 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 62.3835 - Final Residual ratio : 0.0579924 - Residual ratio : 0.000929612 - Slope : -10.3876 - Tolerance : 0.001 - Number of iterations : 6 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.2046 - Final Residual ratio : 0.0112315 - Residual ratio : 0.000652823 - Slope : -1.71933 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.95247 - Final Residual ratio : 0.00596405 - Residual ratio : 0.000666191 - Slope : -0.745542 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2141 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 33.6711 - Final Residual ratio : 0.0276029 - Residual ratio : 0.000819778 - Slope : -2.58796 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.34355 - Final Residual ratio : 0.00763315 - Residual ratio : 0.000914856 - Slope : -0.595423 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.03917 - Final Residual ratio : 0.00674834 - Residual ratio : 0.000958683 - Slope : -0.502316 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.33312 - Final Residual ratio : 0.00389534 - Residual ratio : 0.000898968 - Slope : -0.333018 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.74137 - Final Residual ratio : 0.00256001 - Residual ratio : 0.00053993 - Slope : -0.338487 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2191 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.10739 - Final Residual ratio : 0.00386269 - Residual ratio : 0.000756294 - Slope : -0.364538 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 43.5247 - Final Residual ratio : 0.0348931 - Residual ratio : 0.000801685 - Slope : -3.95362 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 92.1508 - Final Residual ratio : 0.0534795 - Residual ratio : 0.000580348 - Slope : -6.13982 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 34.4033 - Final Residual ratio : 0.0222381 - Residual ratio : 0.000646394 - Slope : -2.29207 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.643 - Final Residual ratio : 0.00991683 - Residual ratio : 0.000931773 - Slope : -0.70887 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2241 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.59081 - Final Residual ratio : 0.00631526 - Residual ratio : 0.000958192 - Slope : -0.438966 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.269 - Final Residual ratio : 0.0155 - Residual ratio : 0.000480337 - Slope : -1.89726 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.945 - Final Residual ratio : 0.0159101 - Residual ratio : 0.000724996 - Slope : -1.56637 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.0864 - Final Residual ratio : 0.0163506 - Residual ratio : 0.000904027 - Slope : -1.29072 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.91527 - Final Residual ratio : 0.00345716 - Residual ratio : 0.000882995 - Slope : -0.279415 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2291 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.4432 - Final Residual ratio : 0.00183113 - Residual ratio : 0.000531811 - Slope : -0.229425 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.1786 - Final Residual ratio : 0.0409914 - Residual ratio : 0.000971854 - Slope : -3.83069 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 59.0742 - Final Residual ratio : 0.0518948 - Residual ratio : 0.000878467 - Slope : -6.55804 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3472 - Final Residual ratio : 0.0095977 - Residual ratio : 0.000587117 - Slope : -1.25674 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.6111 - Final Residual ratio : 0.00838026 - Residual ratio : 0.000973192 - Slope : -0.661748 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2341 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.04329 - Final Residual ratio : 0.00271976 - Residual ratio : 0.00067266 - Slope : -0.269371 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.61228 - Final Residual ratio : 0.00278264 - Residual ratio : 0.000770328 - Slope : -0.36095 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.2259 - Final Residual ratio : 0.00316008 - Residual ratio : 0.000979597 - Slope : -0.214849 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.96763 - Final Residual ratio : 0.00145222 - Residual ratio : 0.000489354 - Slope : -0.228167 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.81297 - Final Residual ratio : 0.00163694 - Residual ratio : 0.000581927 - Slope : -0.187422 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2391 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 42.3914 - Final Residual ratio : 0.0358979 - Residual ratio : 0.000846819 - Slope : -4.23555 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 58.3267 - Final Residual ratio : 0.0528696 - Residual ratio : 0.000906439 - Slope : -7.28423 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.0802 - Final Residual ratio : 0.012582 - Residual ratio : 0.000834335 - Slope : -1.25564 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 8.0892 - Final Residual ratio : 0.00745296 - Residual ratio : 0.000921347 - Slope : -0.673479 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.60065 - Final Residual ratio : 0.00328197 - Residual ratio : 0.000911494 - Slope : -0.276721 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2441 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.94302 - Final Residual ratio : 0.00198946 - Residual ratio : 0.000675993 - Slope : -0.196069 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 47.8937 - Final Residual ratio : 0.0467079 - Residual ratio : 0.000975242 - Slope : -7.9745 - Tolerance : 0.001 - Number of iterations : 6 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.1364 - Final Residual ratio : 0.0540566 - Residual ratio : 0.000781882 - Slope : -4.60549 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.532 - Final Residual ratio : 0.022661 - Residual ratio : 0.000742205 - Slope : -2.03396 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.58224 - Final Residual ratio : 0.00395206 - Residual ratio : 0.00070797 - Slope : -0.348643 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2491 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.754 - Final Residual ratio : 0.0165151 - Residual ratio : 0.000504217 - Slope : -1.92574 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.3443 - Final Residual ratio : 0.0180287 - Residual ratio : 0.000806857 - Slope : -1.59473 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.39 - Final Residual ratio : 0.0126858 - Residual ratio : 0.000689824 - Slope : -1.31266 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.76502 - Final Residual ratio : 0.00245085 - Residual ratio : 0.000886378 - Slope : -0.17266 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.6144 - Final Residual ratio : 0.00115073 - Residual ratio : 0.000712792 - Slope : -0.10755 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2541 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67755 - Final Residual ratio : 0.000666957 - Residual ratio : 0.000397578 - Slope : -0.111792 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.66595 - Final Residual ratio : 0.00121752 - Residual ratio : 0.000730823 - Slope : -0.104046 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.6867 - Final Residual ratio : 0.00152807 - Residual ratio : 0.000905953 - Slope : -0.105323 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65478 - Final Residual ratio : 0.000655734 - Residual ratio : 0.000396267 - Slope : -0.0787678 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57406 - Final Residual ratio : 0.0013814 - Residual ratio : 0.000877606 - Slope : -0.0982924 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2591 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41827 - Final Residual ratio : 0.00118172 - Residual ratio : 0.000833215 - Slope : -0.0944723 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27611 - Final Residual ratio : 0.000994339 - Residual ratio : 0.000779194 - Slope : -0.0910798 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14468 - Final Residual ratio : 0.000676582 - Residual ratio : 0.000591068 - Slope : -0.0762667 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03696 - Final Residual ratio : 0.000584795 - Residual ratio : 0.000563953 - Slope : -0.0740266 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.992394 - Final Residual ratio : 0.000938421 - Residual ratio : 0.000945613 - Slope : -0.061966 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2641 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.860522 - Final Residual ratio : 0.000638275 - Residual ratio : 0.00074173 - Slope : -0.071657 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04506 - Final Residual ratio : 0.000972371 - Residual ratio : 0.000930443 - Slope : -0.0652556 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11389 - Final Residual ratio : 0.000824816 - Residual ratio : 0.000740485 - Slope : -0.0695664 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14178 - Final Residual ratio : 0.00060411 - Residual ratio : 0.000529097 - Slope : -0.0713232 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13421 - Final Residual ratio : 0.00078292 - Residual ratio : 0.000690275 - Slope : -0.0755621 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2691 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.846934 - Final Residual ratio : 0.000720391 - Residual ratio : 0.000850587 - Slope : -0.0604438 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03268 - Final Residual ratio : 0.000445739 - Residual ratio : 0.000431635 - Slope : -0.0645144 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.996926 - Final Residual ratio : 0.000778067 - Residual ratio : 0.000780466 - Slope : -0.0622592 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.969104 - Final Residual ratio : 0.000625283 - Residual ratio : 0.000645218 - Slope : -0.0605299 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.966921 - Final Residual ratio : 0.000513218 - Residual ratio : 0.000530776 - Slope : -0.0604005 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2741 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 70.8341 - Final Residual ratio : 0.0547626 - Residual ratio : 0.000773111 - Slope : -4.71862 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.1731 - Final Residual ratio : 0.0213993 - Residual ratio : 0.000709217 - Slope : -2.01011 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.25777 - Final Residual ratio : 0.00277779 - Residual ratio : 0.000528322 - Slope : -0.328437 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.81367 - Final Residual ratio : 0.00379483 - Residual ratio : 0.000788344 - Slope : -0.300617 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.415 - Final Residual ratio : 0.0159646 - Residual ratio : 0.000492505 - Slope : -1.90582 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2791 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.8831 - Final Residual ratio : 0.0134002 - Residual ratio : 0.000612352 - Slope : -1.56212 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.952 - Final Residual ratio : 0.0151491 - Residual ratio : 0.00084387 - Slope : -1.2812 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.60525 - Final Residual ratio : 0.00240369 - Residual ratio : 0.000922634 - Slope : -0.173523 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.60692 - Final Residual ratio : 0.000813334 - Residual ratio : 0.000506143 - Slope : -0.114722 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.73758 - Final Residual ratio : 0.00147401 - Residual ratio : 0.000848313 - Slope : -0.11574 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2841 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.73904 - Final Residual ratio : 0.000780507 - Residual ratio : 0.000448814 - Slope : -0.108641 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.68657 - Final Residual ratio : 0.00111695 - Residual ratio : 0.000662264 - Slope : -0.105341 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53504 - Final Residual ratio : 0.00114348 - Residual ratio : 0.000744921 - Slope : -0.127825 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33146 - Final Residual ratio : 0.000683373 - Residual ratio : 0.00051325 - Slope : -0.0831738 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12229 - Final Residual ratio : 0.000674175 - Residual ratio : 0.000600715 - Slope : -0.0801153 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2891 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.957019 - Final Residual ratio : 0.00085109 - Residual ratio : 0.000889314 - Slope : -0.0637445 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.858363 - Final Residual ratio : 0.000683321 - Residual ratio : 0.000796075 - Slope : -0.053605 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.82809 - Final Residual ratio : 0.000518444 - Residual ratio : 0.000626072 - Slope : -0.0486807 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.819315 - Final Residual ratio : 0.000574515 - Residual ratio : 0.000701214 - Slope : -0.0481612 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.797768 - Final Residual ratio : 0.000699062 - Residual ratio : 0.000876273 - Slope : -0.0498168 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2941 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.724117 - Final Residual ratio : 0.000334242 - Residual ratio : 0.000461585 - Slope : -0.0452364 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.686457 - Final Residual ratio : 0.000426633 - Residual ratio : 0.000621501 - Slope : -0.0457353 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.648581 - Final Residual ratio : 0.000463765 - Residual ratio : 0.000715046 - Slope : -0.0405074 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.640242 - Final Residual ratio : 0.000612757 - Residual ratio : 0.000957071 - Slope : -0.0399768 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.3627 - Final Residual ratio : 0.051718 - Residual ratio : 0.000745617 - Slope : -4.62073 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.2991 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.8304 - Final Residual ratio : 0.0196625 - Residual ratio : 0.000659143 - Slope : -1.98738 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.18447 - Final Residual ratio : 0.0035071 - Residual ratio : 0.000676462 - Slope : -0.32381 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.7727 - Final Residual ratio : 0.0160923 - Residual ratio : 0.000491028 - Slope : -1.92686 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 22.2107 - Final Residual ratio : 0.0167864 - Residual ratio : 0.000755779 - Slope : -1.58528 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.3284 - Final Residual ratio : 0.00923617 - Residual ratio : 0.000503927 - Slope : -1.30851 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3041 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.53326 - Final Residual ratio : 0.00144902 - Residual ratio : 0.000571997 - Slope : -0.14893 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13387 - Final Residual ratio : 0.000537066 - Residual ratio : 0.000473658 - Slope : -0.0708333 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2051 - Final Residual ratio : 0.00115514 - Residual ratio : 0.000958538 - Slope : -0.0859963 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26517 - Final Residual ratio : 0.001263 - Residual ratio : 0.00099828 - Slope : -0.0902792 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.25038 - Final Residual ratio : 0.000776977 - Residual ratio : 0.000621395 - Slope : -0.0780999 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3091 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12394 - Final Residual ratio : 0.000904163 - Residual ratio : 0.000804456 - Slope : -0.07019 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06836 - Final Residual ratio : 0.000940407 - Residual ratio : 0.000880235 - Slope : -0.0667136 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.965914 - Final Residual ratio : 0.000353816 - Residual ratio : 0.000366302 - Slope : -0.0567976 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.856879 - Final Residual ratio : 0.000544187 - Residual ratio : 0.00063508 - Slope : -0.0535209 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.750764 - Final Residual ratio : 0.000646047 - Residual ratio : 0.00086052 - Slope : -0.0468824 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3141 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.587515 - Final Residual ratio : 0.000171702 - Residual ratio : 0.000292251 - Slope : -0.036709 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.56215 - Final Residual ratio : 0.000474924 - Residual ratio : 0.000844835 - Slope : -0.0351047 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.510048 - Final Residual ratio : 0.000435441 - Residual ratio : 0.000853725 - Slope : -0.0339742 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.476523 - Final Residual ratio : 0.000344483 - Residual ratio : 0.000722908 - Slope : -0.0317453 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.464281 - Final Residual ratio : 0.000301859 - Residual ratio : 0.000650164 - Slope : -0.0272929 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3191 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.418838 - Final Residual ratio : 0.000385242 - Residual ratio : 0.000919787 - Slope : -0.0261533 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.473858 - Final Residual ratio : 0.000219183 - Residual ratio : 0.000462549 - Slope : -0.0296024 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.487778 - Final Residual ratio : 0.000286845 - Residual ratio : 0.000588065 - Slope : -0.0324994 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.493899 - Final Residual ratio : 0.000477464 - Residual ratio : 0.000966725 - Slope : -0.0352444 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.492304 - Final Residual ratio : 0.000475373 - Residual ratio : 0.000965608 - Slope : -0.0327886 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3241 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.415399 - Final Residual ratio : 0.000316651 - Residual ratio : 0.000762281 - Slope : -0.0259426 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.457401 - Final Residual ratio : 0.000230071 - Residual ratio : 0.000502996 - Slope : -0.0285732 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.442976 - Final Residual ratio : 0.000427198 - Residual ratio : 0.000964382 - Slope : -0.0295033 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.423553 - Final Residual ratio : 0.00030354 - Residual ratio : 0.00071665 - Slope : -0.0302321 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.407483 - Final Residual ratio : 0.000273369 - Residual ratio : 0.000670872 - Slope : -0.0370191 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3291 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 71.2624 - Final Residual ratio : 0.0564469 - Residual ratio : 0.0007921 - Slope : -4.74706 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.1193 - Final Residual ratio : 0.0222363 - Residual ratio : 0.000738275 - Slope : -2.00647 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.13325 - Final Residual ratio : 0.00253961 - Residual ratio : 0.000494738 - Slope : -0.32067 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.70446 - Final Residual ratio : 0.00341413 - Residual ratio : 0.000725722 - Slope : -0.293815 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.3988 - Final Residual ratio : 0.0159005 - Residual ratio : 0.000490773 - Slope : -1.90488 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3341 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.8605 - Final Residual ratio : 0.0139097 - Residual ratio : 0.000636296 - Slope : -1.56047 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.9016 - Final Residual ratio : 0.014911 - Residual ratio : 0.000832942 - Slope : -1.27762 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.60459 - Final Residual ratio : 0.00256863 - Residual ratio : 0.000986193 - Slope : -0.185859 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53449 - Final Residual ratio : 0.00144339 - Residual ratio : 0.000940632 - Slope : -0.117927 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63558 - Final Residual ratio : 0.00142389 - Residual ratio : 0.000870573 - Slope : -0.116725 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3391 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.59268 - Final Residual ratio : 0.00122892 - Residual ratio : 0.000771608 - Slope : -0.0994655 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55229 - Final Residual ratio : 0.00126315 - Residual ratio : 0.000813731 - Slope : -0.0969393 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.39534 - Final Residual ratio : 0.00130183 - Residual ratio : 0.00093298 - Slope : -0.0871276 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.19699 - Final Residual ratio : 0.000968323 - Residual ratio : 0.000808962 - Slope : -0.0797351 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0068 - Final Residual ratio : 0.000564808 - Residual ratio : 0.000560992 - Slope : -0.0670825 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3441 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.83384 - Final Residual ratio : 0.000792286 - Residual ratio : 0.000950165 - Slope : -0.0555365 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.796925 - Final Residual ratio : 0.000518943 - Residual ratio : 0.000651182 - Slope : -0.0497754 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.777162 - Final Residual ratio : 0.000671311 - Residual ratio : 0.000863797 - Slope : -0.051766 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.756718 - Final Residual ratio : 0.000373542 - Residual ratio : 0.000493634 - Slope : -0.0444909 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.711541 - Final Residual ratio : 0.000448978 - Residual ratio : 0.000630995 - Slope : -0.0418289 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3491 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.595859 - Final Residual ratio : 0.000564512 - Residual ratio : 0.000947393 - Slope : -0.0372059 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.566369 - Final Residual ratio : 0.000476433 - Residual ratio : 0.000841206 - Slope : -0.0353683 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.6043 - Final Residual ratio : 0.0652754 - Residual ratio : 0.000965551 - Slope : -8.44238 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 12.8067 - Final Residual ratio : 0.0112302 - Residual ratio : 0.000876904 - Slope : -1.06629 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 70.0045 - Final Residual ratio : 0.0535575 - Residual ratio : 0.000765058 - Slope : -4.6634 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3541 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.8353 - Final Residual ratio : 0.0192448 - Residual ratio : 0.000645036 - Slope : -1.98773 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.31103 - Final Residual ratio : 0.0052299 - Residual ratio : 0.000828692 - Slope : -0.394113 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.81872 - Final Residual ratio : 0.00485009 - Residual ratio : 0.000833533 - Slope : -0.363367 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 32.1122 - Final Residual ratio : 0.0153864 - Residual ratio : 0.000479146 - Slope : -1.88805 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.7544 - Final Residual ratio : 0.0130259 - Residual ratio : 0.000598768 - Slope : -1.55296 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3591 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.8718 - Final Residual ratio : 0.0111361 - Residual ratio : 0.00062311 - Slope : -1.27576 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.33394 - Final Residual ratio : 0.00247651 - Residual ratio : 0.000742817 - Slope : -0.222098 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.4373 - Final Residual ratio : 0.00202202 - Residual ratio : 0.000829615 - Slope : -0.162352 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.34158 - Final Residual ratio : 0.00117403 - Residual ratio : 0.000501385 - Slope : -0.180031 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.23169 - Final Residual ratio : 0.00201261 - Residual ratio : 0.000901834 - Slope : -0.159263 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3641 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.0138 - Final Residual ratio : 0.00179056 - Residual ratio : 0.000889146 - Slope : -0.134134 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8901 - Final Residual ratio : 0.00116022 - Residual ratio : 0.000613842 - Slope : -0.118059 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70372 - Final Residual ratio : 0.00124728 - Residual ratio : 0.000732092 - Slope : -0.106405 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51635 - Final Residual ratio : 0.00109927 - Residual ratio : 0.000724945 - Slope : -0.0947031 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34243 - Final Residual ratio : 0.00127532 - Residual ratio : 0.000950008 - Slope : -0.0894104 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3691 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13379 - Final Residual ratio : 0.00105195 - Residual ratio : 0.000927815 - Slope : -0.08091 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05975 - Final Residual ratio : 0.000702855 - Residual ratio : 0.000663225 - Slope : -0.0661907 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.964573 - Final Residual ratio : 0.000693991 - Residual ratio : 0.000719479 - Slope : -0.0602424 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.886315 - Final Residual ratio : 0.000615594 - Residual ratio : 0.000694554 - Slope : -0.0553562 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.822692 - Final Residual ratio : 0.000581667 - Residual ratio : 0.000707029 - Slope : -0.0513819 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3741 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.73888 - Final Residual ratio : 0.000527422 - Residual ratio : 0.000713814 - Slope : -0.046147 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.72733 - Final Residual ratio : 0.000456197 - Residual ratio : 0.000627222 - Slope : -0.0454296 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.701826 - Final Residual ratio : 0.000662969 - Residual ratio : 0.000944635 - Slope : -0.0539356 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.685846 - Final Residual ratio : 0.000645335 - Residual ratio : 0.000940933 - Slope : -0.04568 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.676699 - Final Residual ratio : 0.000376291 - Residual ratio : 0.000556068 - Slope : -0.0422702 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3791 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.4358 - Final Residual ratio : 0.0533439 - Residual ratio : 0.000768248 - Slope : -4.62549 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.4329 - Final Residual ratio : 0.0199967 - Residual ratio : 0.000679399 - Slope : -1.96086 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.11531 - Final Residual ratio : 0.00325738 - Residual ratio : 0.000636789 - Slope : -0.319504 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.66005 - Final Residual ratio : 0.00397245 - Residual ratio : 0.000852449 - Slope : -0.291005 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.41377 - Final Residual ratio : 0.00414549 - Residual ratio : 0.000765731 - Slope : -0.360641 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3841 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.0378 - Final Residual ratio : 0.0144546 - Residual ratio : 0.000481213 - Slope : -1.76608 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.7124 - Final Residual ratio : 0.0124724 - Residual ratio : 0.000602171 - Slope : -1.47857 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.2857 - Final Residual ratio : 0.0139813 - Residual ratio : 0.000808834 - Slope : -1.23369 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.71593 - Final Residual ratio : 0.00173225 - Residual ratio : 0.000637813 - Slope : -0.169637 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.85416 - Final Residual ratio : 0.00125832 - Residual ratio : 0.000678648 - Slope : -0.142531 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3891 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83665 - Final Residual ratio : 0.00157766 - Residual ratio : 0.000858985 - Slope : -0.122338 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82691 - Final Residual ratio : 0.00144447 - Residual ratio : 0.000790658 - Slope : -0.114092 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.69893 - Final Residual ratio : 0.00143947 - Residual ratio : 0.000847278 - Slope : -0.106093 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51149 - Final Residual ratio : 0.00146783 - Residual ratio : 0.000971113 - Slope : -0.100668 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.3015 - Final Residual ratio : 0.000793602 - Residual ratio : 0.000609757 - Slope : -0.0812944 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3941 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05523 - Final Residual ratio : 0.000405248 - Residual ratio : 0.000384037 - Slope : -0.0753447 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.944591 - Final Residual ratio : 0.000854292 - Residual ratio : 0.000904404 - Slope : -0.0629158 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.855371 - Final Residual ratio : 0.000547643 - Residual ratio : 0.000640241 - Slope : -0.0502837 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.803002 - Final Residual ratio : 0.000441155 - Residual ratio : 0.000549383 - Slope : -0.0472095 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.762165 - Final Residual ratio : 0.000424553 - Residual ratio : 0.000557035 - Slope : -0.0448083 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.3991 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.673665 - Final Residual ratio : 0.000668472 - Residual ratio : 0.000992292 - Slope : -0.039588 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.648447 - Final Residual ratio : 0.000365125 - Residual ratio : 0.000563077 - Slope : -0.0405051 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.8329 - Final Residual ratio : 0.0528137 - Residual ratio : 0.000790236 - Slope : -4.452 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.1121 - Final Residual ratio : 0.0199471 - Residual ratio : 0.000685184 - Slope : -1.93948 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.17438 - Final Residual ratio : 0.00461721 - Residual ratio : 0.000892321 - Slope : -0.32311 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4041 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.40021 - Final Residual ratio : 0.00228926 - Residual ratio : 0.000520261 - Slope : -0.258701 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.22643 - Final Residual ratio : 0.0035891 - Residual ratio : 0.000686721 - Slope : -0.326427 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.3933 - Final Residual ratio : 0.0139738 - Residual ratio : 0.000475407 - Slope : -1.7282 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.3715 - Final Residual ratio : 0.0160119 - Residual ratio : 0.000785993 - Slope : -1.45397 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.1967 - Final Residual ratio : 0.0118509 - Residual ratio : 0.000689135 - Slope : -1.22749 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4091 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.63288 - Final Residual ratio : 0.00145596 - Residual ratio : 0.000552989 - Slope : -0.164464 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.69769 - Final Residual ratio : 0.000800096 - Residual ratio : 0.000471286 - Slope : -0.13053 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.72553 - Final Residual ratio : 0.0014958 - Residual ratio : 0.000866862 - Slope : -0.123145 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67981 - Final Residual ratio : 0.00125888 - Residual ratio : 0.000749418 - Slope : -0.111903 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56335 - Final Residual ratio : 0.00135783 - Residual ratio : 0.000868538 - Slope : -0.0918822 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4141 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36289 - Final Residual ratio : 0.0013359 - Residual ratio : 0.000980196 - Slope : -0.0972539 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24364 - Final Residual ratio : 0.000752646 - Residual ratio : 0.000605196 - Slope : -0.0828591 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11328 - Final Residual ratio : 0.000978121 - Residual ratio : 0.000878596 - Slope : -0.0741533 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00122 - Final Residual ratio : 0.000938859 - Residual ratio : 0.00093771 - Slope : -0.0666857 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.903664 - Final Residual ratio : 0.000716227 - Residual ratio : 0.000792581 - Slope : -0.0564342 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4191 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.771119 - Final Residual ratio : 0.000700048 - Residual ratio : 0.000907835 - Slope : -0.0481512 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.703347 - Final Residual ratio : 0.000620672 - Residual ratio : 0.000882455 - Slope : -0.0413368 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.618659 - Final Residual ratio : 0.000319143 - Residual ratio : 0.000515862 - Slope : -0.0386463 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.555167 - Final Residual ratio : 0.000376438 - Residual ratio : 0.000678062 - Slope : -0.036986 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.534592 - Final Residual ratio : 0.000442113 - Residual ratio : 0.00082701 - Slope : -0.0333844 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4241 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.491463 - Final Residual ratio : 0.000475919 - Residual ratio : 0.000968372 - Slope : -0.0306867 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.7121 - Final Residual ratio : 0.0502996 - Residual ratio : 0.000753981 - Slope : -4.44412 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.7756 - Final Residual ratio : 0.0197326 - Residual ratio : 0.000685739 - Slope : -1.91706 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.13683 - Final Residual ratio : 0.00263941 - Residual ratio : 0.000513821 - Slope : -0.320887 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.42564 - Final Residual ratio : 0.00322755 - Residual ratio : 0.000729285 - Slope : -0.276401 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4291 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.8576 - Final Residual ratio : 0.0151987 - Residual ratio : 0.000492544 - Slope : -1.81426 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.1838 - Final Residual ratio : 0.0133263 - Residual ratio : 0.000629077 - Slope : -1.51218 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.449 - Final Residual ratio : 0.01073 - Residual ratio : 0.000614936 - Slope : -1.24559 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.38662 - Final Residual ratio : 0.00208326 - Residual ratio : 0.000872891 - Slope : -0.149034 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34933 - Final Residual ratio : 0.00112727 - Residual ratio : 0.000835434 - Slope : -0.103708 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4341 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.44082 - Final Residual ratio : 0.00142292 - Residual ratio : 0.000987581 - Slope : -0.110723 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50594 - Final Residual ratio : 0.00112926 - Residual ratio : 0.000749866 - Slope : -0.0940509 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47469 - Final Residual ratio : 0.00124437 - Residual ratio : 0.00084382 - Slope : -0.0920901 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37444 - Final Residual ratio : 0.00126686 - Residual ratio : 0.000921728 - Slope : -0.0858236 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.23008 - Final Residual ratio : 0.000536209 - Residual ratio : 0.000435914 - Slope : -0.0723261 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4391 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02085 - Final Residual ratio : 0.000740471 - Residual ratio : 0.000725349 - Slope : -0.0637567 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.895663 - Final Residual ratio : 0.000565454 - Residual ratio : 0.000631325 - Slope : -0.0639356 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.768593 - Final Residual ratio : 0.000728466 - Residual ratio : 0.000947792 - Slope : -0.051191 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.673191 - Final Residual ratio : 0.000574966 - Residual ratio : 0.000854091 - Slope : -0.0448411 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.611019 - Final Residual ratio : 0.000553223 - Residual ratio : 0.00090541 - Slope : -0.0359098 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4441 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.563509 - Final Residual ratio : 0.000519408 - Residual ratio : 0.000921738 - Slope : -0.0331171 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.531113 - Final Residual ratio : 0.000490928 - Residual ratio : 0.000924337 - Slope : -0.0312131 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.501601 - Final Residual ratio : 0.000249458 - Residual ratio : 0.000497323 - Slope : -0.0263869 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.478458 - Final Residual ratio : 0.000337063 - Residual ratio : 0.000704479 - Slope : -0.0298825 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.471724 - Final Residual ratio : 0.000324348 - Residual ratio : 0.00068758 - Slope : -0.0277294 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4491 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.428777 - Final Residual ratio : 0.000232014 - Residual ratio : 0.000541107 - Slope : -0.0252085 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.481535 - Final Residual ratio : 0.000363997 - Residual ratio : 0.00075591 - Slope : -0.0300732 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 68.2318 - Final Residual ratio : 0.0512631 - Residual ratio : 0.000751308 - Slope : -4.54537 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.794 - Final Residual ratio : 0.0195351 - Residual ratio : 0.000678444 - Slope : -1.9183 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.07951 - Final Residual ratio : 0.00280516 - Residual ratio : 0.000552251 - Slope : -0.317294 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4541 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.44661 - Final Residual ratio : 0.00372444 - Residual ratio : 0.00083759 - Slope : -0.277681 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.20687 - Final Residual ratio : 0.00386162 - Residual ratio : 0.00074164 - Slope : -0.346867 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.435 - Final Residual ratio : 0.0138983 - Residual ratio : 0.00047217 - Slope : -1.73065 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.4301 - Final Residual ratio : 0.0111467 - Residual ratio : 0.000545603 - Slope : -1.45849 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.0447 - Final Residual ratio : 0.0137743 - Residual ratio : 0.000808127 - Slope : -1.21649 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4591 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.67811 - Final Residual ratio : 0.0020753 - Residual ratio : 0.000774912 - Slope : -0.167252 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7525 - Final Residual ratio : 0.00116519 - Residual ratio : 0.000664875 - Slope : -0.134718 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.78009 - Final Residual ratio : 0.00170384 - Residual ratio : 0.000957163 - Slope : -0.136799 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7458 - Final Residual ratio : 0.00146306 - Residual ratio : 0.000838049 - Slope : -0.109021 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63414 - Final Residual ratio : 0.00139501 - Residual ratio : 0.000853665 - Slope : -0.102047 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4641 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41472 - Final Residual ratio : 0.00102825 - Residual ratio : 0.000726821 - Slope : -0.0883559 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2521 - Final Residual ratio : 0.00120984 - Residual ratio : 0.000966255 - Slope : -0.0735816 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0625 - Final Residual ratio : 0.000498502 - Residual ratio : 0.000469177 - Slope : -0.0708003 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.898992 - Final Residual ratio : 0.000884834 - Residual ratio : 0.000984252 - Slope : -0.0598738 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.786821 - Final Residual ratio : 0.00068941 - Residual ratio : 0.000876196 - Slope : -0.0462431 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4691 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.718415 - Final Residual ratio : 0.000549518 - Residual ratio : 0.000764903 - Slope : -0.0422274 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.681381 - Final Residual ratio : 0.000526564 - Residual ratio : 0.000772789 - Slope : -0.0400502 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.641275 - Final Residual ratio : 0.000477094 - Residual ratio : 0.000743978 - Slope : -0.037694 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.585796 - Final Residual ratio : 0.000390993 - Residual ratio : 0.000667455 - Slope : -0.0344356 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.528189 - Final Residual ratio : 0.000302754 - Residual ratio : 0.000573193 - Slope : -0.0329929 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4741 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.452874 - Final Residual ratio : 0.000431766 - Residual ratio : 0.000953391 - Slope : -0.0323173 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.9921 - Final Residual ratio : 0.051066 - Residual ratio : 0.000762269 - Slope : -4.46274 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.5714 - Final Residual ratio : 0.0186501 - Residual ratio : 0.000652754 - Slope : -1.90352 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.09056 - Final Residual ratio : 0.00359312 - Residual ratio : 0.000705839 - Slope : -0.423914 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48242 - Final Residual ratio : 0.00401076 - Residual ratio : 0.000894777 - Slope : -0.2799 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4791 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 30.9045 - Final Residual ratio : 0.0151915 - Residual ratio : 0.000491563 - Slope : -1.81702 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.1014 - Final Residual ratio : 0.0164134 - Residual ratio : 0.000777833 - Slope : -1.50607 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.3532 - Final Residual ratio : 0.0113901 - Residual ratio : 0.000656373 - Slope : -1.2387 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.31021 - Final Residual ratio : 0.00180599 - Residual ratio : 0.000781744 - Slope : -0.153894 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24774 - Final Residual ratio : 0.000674072 - Residual ratio : 0.000540234 - Slope : -0.0890762 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4841 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36568 - Final Residual ratio : 0.000473653 - Residual ratio : 0.000346825 - Slope : -0.105016 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41863 - Final Residual ratio : 0.00109561 - Residual ratio : 0.000772301 - Slope : -0.0945023 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38032 - Final Residual ratio : 0.00132709 - Residual ratio : 0.000961438 - Slope : -0.0919327 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27534 - Final Residual ratio : 0.000220739 - Residual ratio : 0.000173083 - Slope : -0.07084 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13441 - Final Residual ratio : 0.0009752 - Residual ratio : 0.000859656 - Slope : -0.0708395 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4891 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.946676 - Final Residual ratio : 0.000878426 - Residual ratio : 0.000927905 - Slope : -0.067557 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.832404 - Final Residual ratio : 0.000520888 - Residual ratio : 0.000625763 - Slope : -0.0594202 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.723409 - Final Residual ratio : 0.000431308 - Residual ratio : 0.000596216 - Slope : -0.0481985 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.634358 - Final Residual ratio : 0.000564037 - Residual ratio : 0.000889146 - Slope : -0.0396121 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.56333 - Final Residual ratio : 0.000504913 - Residual ratio : 0.0008963 - Slope : -0.0351766 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4941 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.481962 - Final Residual ratio : 0.000191613 - Residual ratio : 0.000397568 - Slope : -0.0229415 - Tolerance : 0.001 - Number of iterations : 21 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.442309 - Final Residual ratio : 0.000377678 - Residual ratio : 0.000853877 - Slope : -0.0276207 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.409157 - Final Residual ratio : 0.000341846 - Residual ratio : 0.000835488 - Slope : -0.025551 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.390227 - Final Residual ratio : 0.000316501 - Residual ratio : 0.000811069 - Slope : -0.0243694 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.39023 - Final Residual ratio : 0.000321772 - Residual ratio : 0.000824571 - Slope : -0.0243692 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.4991 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.379485 - Final Residual ratio : 0.00025813 - Residual ratio : 0.000680211 - Slope : -0.0237017 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.40166 - Final Residual ratio : 0.000320903 - Residual ratio : 0.000798943 - Slope : -0.0250837 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 68.2224 - Final Residual ratio : 0.0525401 - Residual ratio : 0.00077013 - Slope : -4.54465 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -writing a 2D mesh -0.001 -******** CURRENT TIME = 1.5021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.6262 - Final Residual ratio : 0.0203774 - Residual ratio : 0.000711843 - Slope : -1.90706 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.03002 - Final Residual ratio : 0.00237501 - Residual ratio : 0.000472167 - Slope : -0.314228 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5041 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.37398 - Final Residual ratio : 0.00349036 - Residual ratio : 0.000797982 - Slope : -0.273155 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.054 - Final Residual ratio : 0.0151552 - Residual ratio : 0.000488025 - Slope : -1.82582 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.1687 - Final Residual ratio : 0.013969 - Residual ratio : 0.000659889 - Slope : -1.51105 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.3204 - Final Residual ratio : 0.0122467 - Residual ratio : 0.00070707 - Slope : -1.2363 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.35609 - Final Residual ratio : 0.00185204 - Residual ratio : 0.000786066 - Slope : -0.14714 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5091 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.33956 - Final Residual ratio : 0.00115485 - Residual ratio : 0.000862112 - Slope : -0.102954 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43323 - Final Residual ratio : 0.000955836 - Residual ratio : 0.000666912 - Slope : -0.089517 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49596 - Final Residual ratio : 0.00132022 - Residual ratio : 0.000882527 - Slope : -0.0934148 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.46418 - Final Residual ratio : 0.00128174 - Residual ratio : 0.000875402 - Slope : -0.091431 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35678 - Final Residual ratio : 0.0012263 - Residual ratio : 0.00090383 - Slope : -0.0847219 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5141 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.16339 - Final Residual ratio : 0.00110186 - Residual ratio : 0.000947108 - Slope : -0.0894069 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0063 - Final Residual ratio : 0.000674232 - Residual ratio : 0.000670012 - Slope : -0.0670416 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.84091 - Final Residual ratio : 0.000582249 - Residual ratio : 0.000692403 - Slope : -0.0560218 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.709814 - Final Residual ratio : 0.000463309 - Residual ratio : 0.000652719 - Slope : -0.0443344 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.63245 - Final Residual ratio : 0.000462524 - Residual ratio : 0.00073132 - Slope : -0.0371757 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5191 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.610749 - Final Residual ratio : 0.000533003 - Residual ratio : 0.000872703 - Slope : -0.0358951 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.577907 - Final Residual ratio : 0.000519222 - Residual ratio : 0.000898452 - Slope : -0.033964 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.8795 - Final Residual ratio : 0.02365 - Residual ratio : 0.000950584 - Slope : -2.76176 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.28975 - Final Residual ratio : 0.0058798 - Residual ratio : 0.000934822 - Slope : -0.483375 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.28973 - Final Residual ratio : 0.00345011 - Residual ratio : 0.000652229 - Slope : -0.352418 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5241 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.35221 - Final Residual ratio : 0.0016691 - Residual ratio : 0.000709589 - Slope : -0.156703 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.62381 - Final Residual ratio : 0.0019599 - Residual ratio : 0.000746967 - Slope : -0.17479 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.94375 - Final Residual ratio : 0.00192394 - Residual ratio : 0.000653569 - Slope : -0.183864 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.0855 - Final Residual ratio : 0.00186762 - Residual ratio : 0.000605287 - Slope : -0.205576 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.03622 - Final Residual ratio : 0.00183679 - Residual ratio : 0.00060496 - Slope : -0.202292 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5291 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.1871 - Final Residual ratio : 0.0527534 - Residual ratio : 0.000762475 - Slope : -4.60896 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.7402 - Final Residual ratio : 0.0210726 - Residual ratio : 0.000733211 - Slope : -1.91461 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.33667 - Final Residual ratio : 0.00531244 - Residual ratio : 0.000995458 - Slope : -0.355424 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.6107 - Final Residual ratio : 0.00394105 - Residual ratio : 0.00085476 - Slope : -0.307118 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 31.1968 - Final Residual ratio : 0.0151297 - Residual ratio : 0.000484976 - Slope : -1.83422 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5341 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.2084 - Final Residual ratio : 0.0116187 - Residual ratio : 0.000547832 - Slope : -1.51406 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.3418 - Final Residual ratio : 0.0108768 - Residual ratio : 0.000627203 - Slope : -1.23792 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.7506 - Final Residual ratio : 0.00179555 - Residual ratio : 0.000652782 - Slope : -0.161695 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05069 - Final Residual ratio : 0.00108272 - Residual ratio : 0.000527979 - Slope : -0.136641 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.20192 - Final Residual ratio : 0.0013486 - Residual ratio : 0.000612465 - Slope : -0.157184 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5391 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.19528 - Final Residual ratio : 0.00146633 - Residual ratio : 0.000667949 - Slope : -0.137113 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.09817 - Final Residual ratio : 0.0017088 - Residual ratio : 0.000814423 - Slope : -0.131029 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.87525 - Final Residual ratio : 0.00169713 - Residual ratio : 0.000905013 - Slope : -0.117097 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.58736 - Final Residual ratio : 0.000745626 - Residual ratio : 0.000469726 - Slope : -0.0933305 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30189 - Final Residual ratio : 0.000998371 - Residual ratio : 0.000766861 - Slope : -0.0813059 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5441 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08112 - Final Residual ratio : 0.000899604 - Residual ratio : 0.000832107 - Slope : -0.0720145 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02731 - Final Residual ratio : 0.000770139 - Residual ratio : 0.000749663 - Slope : -0.064159 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07369 - Final Residual ratio : 0.000887504 - Residual ratio : 0.000826594 - Slope : -0.0825231 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.13633 - Final Residual ratio : 0.000687628 - Residual ratio : 0.000605129 - Slope : -0.0709779 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14902 - Final Residual ratio : 0.000660379 - Residual ratio : 0.000574734 - Slope : -0.0717722 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5491 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.09147 - Final Residual ratio : 0.000661041 - Residual ratio : 0.000605643 - Slope : -0.0681755 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.939386 - Final Residual ratio : 0.000939145 - Residual ratio : 0.000999744 - Slope : -0.0586529 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.757518 - Final Residual ratio : 0.000636034 - Residual ratio : 0.000839628 - Slope : -0.054063 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.60384 - Final Residual ratio : 0.000442416 - Residual ratio : 0.000732671 - Slope : -0.0377124 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.575419 - Final Residual ratio : 0.000532892 - Residual ratio : 0.000926093 - Slope : -0.0359304 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5541 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.639145 - Final Residual ratio : 0.000572657 - Residual ratio : 0.000895973 - Slope : -0.0399108 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.815115 - Final Residual ratio : 0.000772961 - Residual ratio : 0.000948284 - Slope : -0.0508964 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 69.0092 - Final Residual ratio : 0.0509039 - Residual ratio : 0.000737639 - Slope : -4.59722 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.4789 - Final Residual ratio : 0.019411 - Residual ratio : 0.000681591 - Slope : -1.8973 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.04021 - Final Residual ratio : 0.00305317 - Residual ratio : 0.000605762 - Slope : -0.314823 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5591 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.53751 - Final Residual ratio : 0.00346598 - Residual ratio : 0.000763851 - Slope : -0.283378 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.20348 - Final Residual ratio : 0.00511515 - Residual ratio : 0.000983026 - Slope : -0.371312 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.4154 - Final Residual ratio : 0.0139824 - Residual ratio : 0.000475344 - Slope : -1.72949 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.3645 - Final Residual ratio : 0.0100117 - Residual ratio : 0.000491627 - Slope : -1.45389 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.8945 - Final Residual ratio : 0.0163179 - Residual ratio : 0.000965872 - Slope : -1.20559 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5641 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.73259 - Final Residual ratio : 0.00272514 - Residual ratio : 0.000997273 - Slope : -0.181991 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80817 - Final Residual ratio : 0.00136711 - Residual ratio : 0.000756072 - Slope : -0.129058 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.83031 - Final Residual ratio : 0.00125474 - Residual ratio : 0.000685532 - Slope : -0.114316 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80843 - Final Residual ratio : 0.00105114 - Residual ratio : 0.000581244 - Slope : -0.112961 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.71077 - Final Residual ratio : 0.00127391 - Residual ratio : 0.000744638 - Slope : -0.106844 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5691 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49894 - Final Residual ratio : 0.000947886 - Residual ratio : 0.000632373 - Slope : -0.0936243 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32964 - Final Residual ratio : 0.00103819 - Residual ratio : 0.000780806 - Slope : -0.0830374 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.12249 - Final Residual ratio : 0.000189945 - Residual ratio : 0.000169217 - Slope : -0.0701439 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.94289 - Final Residual ratio : 0.000833419 - Residual ratio : 0.000883898 - Slope : -0.0628038 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.835258 - Final Residual ratio : 0.000659744 - Residual ratio : 0.000789868 - Slope : -0.0556399 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5741 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.815073 - Final Residual ratio : 0.000467507 - Residual ratio : 0.000573577 - Slope : -0.047918 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.822644 - Final Residual ratio : 0.000503033 - Residual ratio : 0.000611483 - Slope : -0.0513838 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.830279 - Final Residual ratio : 0.000596831 - Residual ratio : 0.000718831 - Slope : -0.0518552 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.800652 - Final Residual ratio : 0.000591624 - Residual ratio : 0.000738928 - Slope : -0.0500038 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.734145 - Final Residual ratio : 0.0004389 - Residual ratio : 0.000597839 - Slope : -0.0458566 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5791 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.645157 - Final Residual ratio : 0.000475282 - Residual ratio : 0.000736692 - Slope : -0.0429788 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.1769 - Final Residual ratio : 0.0517632 - Residual ratio : 0.000770551 - Slope : -4.47501 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.2765 - Final Residual ratio : 0.0181152 - Residual ratio : 0.000640646 - Slope : -1.88389 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.00676 - Final Residual ratio : 0.00225214 - Residual ratio : 0.00044982 - Slope : -0.294383 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.54385 - Final Residual ratio : 0.0021878 - Residual ratio : 0.000481486 - Slope : -0.267157 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5841 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.16955 - Final Residual ratio : 0.00332658 - Residual ratio : 0.000643495 - Slope : -0.322889 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 29.1602 - Final Residual ratio : 0.0137388 - Residual ratio : 0.000471149 - Slope : -1.7145 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 20.1395 - Final Residual ratio : 0.0151514 - Residual ratio : 0.000752324 - Slope : -1.43745 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.821 - Final Residual ratio : 0.0122183 - Residual ratio : 0.000726373 - Slope : -1.20063 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.45347 - Final Residual ratio : 0.00169617 - Residual ratio : 0.000691334 - Slope : -0.153236 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5891 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5937 - Final Residual ratio : 0.000887407 - Residual ratio : 0.000556821 - Slope : -0.113772 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63033 - Final Residual ratio : 0.000732932 - Residual ratio : 0.000449561 - Slope : -0.10864 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61614 - Final Residual ratio : 0.000517554 - Residual ratio : 0.00032024 - Slope : -0.0950367 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52424 - Final Residual ratio : 0.00134584 - Residual ratio : 0.000882959 - Slope : -0.0951806 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38435 - Final Residual ratio : 0.000623752 - Residual ratio : 0.000450575 - Slope : -0.0864828 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5941 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1959 - Final Residual ratio : 0.000962237 - Residual ratio : 0.00080461 - Slope : -0.0796628 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06261 - Final Residual ratio : 0.000577092 - Residual ratio : 0.000543087 - Slope : -0.0708025 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.937101 - Final Residual ratio : 0.000607631 - Residual ratio : 0.000648416 - Slope : -0.0624329 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.83054 - Final Residual ratio : 0.000506638 - Residual ratio : 0.00061001 - Slope : -0.0518771 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.739657 - Final Residual ratio : 0.000628088 - Residual ratio : 0.00084916 - Slope : -0.0739029 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.5991 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.635238 - Final Residual ratio : 0.000311524 - Residual ratio : 0.000490405 - Slope : -0.0396829 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.569741 - Final Residual ratio : 0.000366651 - Residual ratio : 0.000643539 - Slope : -0.0379583 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.51057 - Final Residual ratio : 0.000280125 - Residual ratio : 0.000548652 - Slope : -0.0318931 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.471318 - Final Residual ratio : 0.000347515 - Residual ratio : 0.000737327 - Slope : -0.031398 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.461898 - Final Residual ratio : 0.000310593 - Residual ratio : 0.000672427 - Slope : -0.0271522 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6041 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.456943 - Final Residual ratio : 0.000349046 - Residual ratio : 0.000763872 - Slope : -0.0285371 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.482033 - Final Residual ratio : 0.000282064 - Residual ratio : 0.000585155 - Slope : -0.0283383 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.2126 - Final Residual ratio : 0.0514897 - Residual ratio : 0.000766073 - Slope : -4.47741 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.1966 - Final Residual ratio : 0.0201008 - Residual ratio : 0.00071288 - Slope : -1.87843 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.98785 - Final Residual ratio : 0.00492218 - Residual ratio : 0.000986833 - Slope : -0.332195 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6091 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.35206 - Final Residual ratio : 0.00333587 - Residual ratio : 0.000766505 - Slope : -0.271795 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.0195 - Final Residual ratio : 0.0031128 - Residual ratio : 0.000620143 - Slope : -0.334426 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.89941 - Final Residual ratio : 0.00384695 - Residual ratio : 0.000785188 - Slope : -0.349683 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.1359 - Final Residual ratio : 0.0128565 - Residual ratio : 0.00047378 - Slope : -1.59547 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.3524 - Final Residual ratio : 0.0124312 - Residual ratio : 0.000642361 - Slope : -1.38143 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6141 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5496 - Final Residual ratio : 0.00929294 - Residual ratio : 0.000561521 - Slope : -1.18145 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.86818 - Final Residual ratio : 0.00154366 - Residual ratio : 0.000538202 - Slope : -0.179165 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.03417 - Final Residual ratio : 0.00190563 - Residual ratio : 0.00093681 - Slope : -0.145162 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.97298 - Final Residual ratio : 0.00100162 - Residual ratio : 0.000507669 - Slope : -0.131465 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.87258 - Final Residual ratio : 0.00161532 - Residual ratio : 0.00086262 - Slope : -0.116935 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6191 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67458 - Final Residual ratio : 0.00135643 - Residual ratio : 0.000810014 - Slope : -0.104576 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50394 - Final Residual ratio : 0.00115519 - Residual ratio : 0.000768105 - Slope : -0.0939243 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30109 - Final Residual ratio : 0.000878732 - Residual ratio : 0.000675381 - Slope : -0.0866808 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11539 - Final Residual ratio : 0.000993779 - Residual ratio : 0.000890968 - Slope : -0.0796 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.976878 - Final Residual ratio : 0.000757275 - Residual ratio : 0.000775199 - Slope : -0.0610076 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6241 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.910385 - Final Residual ratio : 0.000704087 - Residual ratio : 0.000773395 - Slope : -0.0535106 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.832795 - Final Residual ratio : 0.000668882 - Residual ratio : 0.000803177 - Slope : -0.0489486 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.780951 - Final Residual ratio : 0.000542012 - Residual ratio : 0.000694041 - Slope : -0.0459064 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.716401 - Final Residual ratio : 0.000554758 - Residual ratio : 0.000774368 - Slope : -0.0397692 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.649526 - Final Residual ratio : 0.000454974 - Residual ratio : 0.000700471 - Slope : -0.0405669 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6291 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.2517 - Final Residual ratio : 0.0520359 - Residual ratio : 0.000797465 - Slope : -4.34665 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.9151 - Final Residual ratio : 0.0190563 - Residual ratio : 0.000682651 - Slope : -1.85974 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.08025 - Final Residual ratio : 0.00333433 - Residual ratio : 0.000656332 - Slope : -0.317307 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.42025 - Final Residual ratio : 0.00407929 - Residual ratio : 0.000922865 - Slope : -0.276011 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.99054 - Final Residual ratio : 0.0046043 - Residual ratio : 0.000922607 - Slope : -0.332395 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6341 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.92246 - Final Residual ratio : 0.00488463 - Residual ratio : 0.000992315 - Slope : -0.351255 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.7576 - Final Residual ratio : 0.012238 - Residual ratio : 0.000457363 - Slope : -1.57326 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.0783 - Final Residual ratio : 0.0129411 - Residual ratio : 0.000678314 - Slope : -1.36181 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.4524 - Final Residual ratio : 0.0155305 - Residual ratio : 0.00094397 - Slope : -1.26437 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.71415 - Final Residual ratio : 0.00131809 - Residual ratio : 0.000485636 - Slope : -0.169552 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6391 -dimension in distance computation 2 -elements_to_solve.size() : 50 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.88393 - Final Residual ratio : 0.00100991 - Residual ratio : 0.000536065 - Slope : -0.134494 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80531 - Final Residual ratio : 0.00154918 - Residual ratio : 0.000858126 - Slope : -0.138751 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.69974 - Final Residual ratio : 0.0012132 - Residual ratio : 0.000713756 - Slope : -0.121324 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.6147 - Final Residual ratio : 0.0209911 - Residual ratio : 0.000543603 - Slope : -4.82422 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 14.2966 - Final Residual ratio : 0.0140931 - Residual ratio : 0.000985769 - Slope : -1.42825 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6441 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.57885 - Final Residual ratio : 0.003716 - Residual ratio : 0.000490312 - Slope : -0.541081 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.39564 - Final Residual ratio : 0.00151347 - Residual ratio : 0.000631759 - Slope : -0.199511 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98186 - Final Residual ratio : 0.00113903 - Residual ratio : 0.000574728 - Slope : -0.132048 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80713 - Final Residual ratio : 0.00124167 - Residual ratio : 0.000687098 - Slope : -0.120392 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65756 - Final Residual ratio : 0.00149566 - Residual ratio : 0.000902327 - Slope : -0.110404 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6491 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43933 - Final Residual ratio : 0.00137933 - Residual ratio : 0.000958314 - Slope : -0.110611 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37819 - Final Residual ratio : 0.00129783 - Residual ratio : 0.000941692 - Slope : -0.0983491 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.27153 - Final Residual ratio : 0.00107921 - Residual ratio : 0.000848752 - Slope : -0.0907465 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.18701 - Final Residual ratio : 0.000619412 - Residual ratio : 0.000521824 - Slope : -0.0741496 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.7734 - Final Residual ratio : 0.0491669 - Residual ratio : 0.00075906 - Slope : -4.31495 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6541 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.7805 - Final Residual ratio : 0.0190574 - Residual ratio : 0.000686002 - Slope : -1.85076 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.13821 - Final Residual ratio : 0.00350801 - Residual ratio : 0.00068273 - Slope : -0.320919 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.37259 - Final Residual ratio : 0.00370561 - Residual ratio : 0.000847463 - Slope : -0.273055 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.92847 - Final Residual ratio : 0.00396339 - Residual ratio : 0.000804183 - Slope : -0.328301 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.3014 - Final Residual ratio : 0.0136343 - Residual ratio : 0.000481752 - Slope : -1.66399 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6591 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.8448 - Final Residual ratio : 0.0125985 - Residual ratio : 0.000634848 - Slope : -1.41659 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.6818 - Final Residual ratio : 0.0134478 - Residual ratio : 0.000806135 - Slope : -1.1906 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.47678 - Final Residual ratio : 0.00201829 - Residual ratio : 0.000814887 - Slope : -0.176769 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63483 - Final Residual ratio : 0.000574532 - Residual ratio : 0.000351432 - Slope : -0.125712 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.69293 - Final Residual ratio : 0.0016409 - Residual ratio : 0.000969266 - Slope : -0.112753 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6641 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.66769 - Final Residual ratio : 0.0010209 - Residual ratio : 0.000612164 - Slope : -0.104167 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.60672 - Final Residual ratio : 0.00111999 - Residual ratio : 0.000697066 - Slope : -0.10035 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48405 - Final Residual ratio : 0.00133805 - Residual ratio : 0.000901618 - Slope : -0.0926698 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32379 - Final Residual ratio : 0.000919125 - Residual ratio : 0.000694316 - Slope : -0.0826792 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15416 - Final Residual ratio : 0.000548374 - Residual ratio : 0.000475129 - Slope : -0.0769072 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6691 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.996699 - Final Residual ratio : 0.000733823 - Residual ratio : 0.000736253 - Slope : -0.0663977 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.86803 - Final Residual ratio : 0.000696454 - Residual ratio : 0.000802339 - Slope : -0.0542084 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.782483 - Final Residual ratio : 0.000565459 - Residual ratio : 0.000722647 - Slope : -0.0521278 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.718012 - Final Residual ratio : 0.000619407 - Residual ratio : 0.000862668 - Slope : -0.0421996 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.663671 - Final Residual ratio : 0.000477231 - Residual ratio : 0.000719077 - Slope : -0.0390114 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6741 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.629129 - Final Residual ratio : 0.000424992 - Residual ratio : 0.000675525 - Slope : -0.052392 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.562974 - Final Residual ratio : 0.000317022 - Residual ratio : 0.000563121 - Slope : -0.0351661 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.540634 - Final Residual ratio : 0.000344189 - Residual ratio : 0.00063664 - Slope : -0.0337681 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.537611 - Final Residual ratio : 0.000302093 - Residual ratio : 0.000561917 - Slope : -0.0316064 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.549368 - Final Residual ratio : 0.000500633 - Residual ratio : 0.00091129 - Slope : -0.0343042 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6791 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.4367 - Final Residual ratio : 0.0504079 - Residual ratio : 0.000758736 - Slope : -4.42576 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.7606 - Final Residual ratio : 0.0189557 - Residual ratio : 0.000682827 - Slope : -1.84945 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.00612 - Final Residual ratio : 0.00287635 - Residual ratio : 0.000574566 - Slope : -0.312703 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.38607 - Final Residual ratio : 0.00352107 - Residual ratio : 0.000802785 - Slope : -0.273909 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.9403 - Final Residual ratio : 0.0037001 - Residual ratio : 0.000748962 - Slope : -0.329107 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6841 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.5927 - Final Residual ratio : 0.0137242 - Residual ratio : 0.000479989 - Slope : -1.68112 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9986 - Final Residual ratio : 0.011208 - Residual ratio : 0.000560439 - Slope : -1.42767 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.6302 - Final Residual ratio : 0.0109716 - Residual ratio : 0.000659742 - Slope : -1.18709 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.47053 - Final Residual ratio : 0.0016302 - Residual ratio : 0.00065986 - Slope : -0.154306 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61416 - Final Residual ratio : 0.000744329 - Residual ratio : 0.000461124 - Slope : -0.124109 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6891 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64172 - Final Residual ratio : 0.00109439 - Residual ratio : 0.000666614 - Slope : -0.109375 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64707 - Final Residual ratio : 0.00125641 - Residual ratio : 0.000762815 - Slope : -0.102863 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.57203 - Final Residual ratio : 0.00129638 - Residual ratio : 0.000824654 - Slope : -0.0981709 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4375 - Final Residual ratio : 0.00117846 - Residual ratio : 0.000819795 - Slope : -0.0897701 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26525 - Final Residual ratio : 0.000942022 - Residual ratio : 0.000744537 - Slope : -0.079019 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6941 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04928 - Final Residual ratio : 0.000377849 - Residual ratio : 0.000360103 - Slope : -0.0699269 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.898208 - Final Residual ratio : 0.000696424 - Residual ratio : 0.000775349 - Slope : -0.0598341 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.771533 - Final Residual ratio : 0.000729209 - Residual ratio : 0.000945143 - Slope : -0.0513869 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.690829 - Final Residual ratio : 0.000629569 - Residual ratio : 0.000911324 - Slope : -0.0405999 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.648501 - Final Residual ratio : 0.000525347 - Residual ratio : 0.000810095 - Slope : -0.0381162 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.6991 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.629243 - Final Residual ratio : 0.000440882 - Residual ratio : 0.000700655 - Slope : -0.0369884 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.578969 - Final Residual ratio : 0.000445769 - Residual ratio : 0.000769937 - Slope : -0.0340308 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.533524 - Final Residual ratio : 0.00029121 - Residual ratio : 0.000545824 - Slope : -0.0313666 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.488913 - Final Residual ratio : 0.000400251 - Residual ratio : 0.000818656 - Slope : -0.030532 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.467342 - Final Residual ratio : 0.0003544 - Residual ratio : 0.000758331 - Slope : -0.0274699 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7041 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.5058 - Final Residual ratio : 0.0508083 - Residual ratio : 0.000763967 - Slope : -4.43034 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.7534 - Final Residual ratio : 0.018269 - Residual ratio : 0.000658263 - Slope : -1.84901 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.98319 - Final Residual ratio : 0.00416892 - Residual ratio : 0.000836598 - Slope : -0.452638 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.45505 - Final Residual ratio : 0.00372008 - Residual ratio : 0.000835026 - Slope : -0.278208 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.00509 - Final Residual ratio : 0.00407157 - Residual ratio : 0.000813485 - Slope : -0.333401 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7091 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.9267 - Final Residual ratio : 0.0039427 - Residual ratio : 0.000800273 - Slope : -0.351625 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.8929 - Final Residual ratio : 0.0125088 - Residual ratio : 0.000465133 - Slope : -1.5812 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.1702 - Final Residual ratio : 0.0107337 - Residual ratio : 0.000559917 - Slope : -1.36853 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.378 - Final Residual ratio : 0.0135296 - Residual ratio : 0.000826082 - Slope : -1.2588 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.74875 - Final Residual ratio : 0.00167557 - Residual ratio : 0.000609575 - Slope : -0.171692 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7141 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.91323 - Final Residual ratio : 0.00154348 - Residual ratio : 0.00080674 - Slope : -0.136549 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84558 - Final Residual ratio : 0.00137279 - Residual ratio : 0.000743823 - Slope : -0.115263 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.74882 - Final Residual ratio : 0.00108585 - Residual ratio : 0.000620905 - Slope : -0.109234 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.60189 - Final Residual ratio : 0.0011132 - Residual ratio : 0.000694924 - Slope : -0.100049 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42379 - Final Residual ratio : 0.00104739 - Residual ratio : 0.000735633 - Slope : -0.129341 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7191 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.20301 - Final Residual ratio : 0.000916629 - Residual ratio : 0.000761949 - Slope : -0.0801393 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05726 - Final Residual ratio : 0.000715639 - Residual ratio : 0.00067688 - Slope : -0.0754676 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.924686 - Final Residual ratio : 0.000577579 - Residual ratio : 0.000624622 - Slope : -0.0616072 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.822245 - Final Residual ratio : 0.000502615 - Residual ratio : 0.000611272 - Slope : -0.0483378 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.743483 - Final Residual ratio : 0.000445649 - Residual ratio : 0.000599407 - Slope : -0.0437081 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7241 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.663208 - Final Residual ratio : 0.00048113 - Residual ratio : 0.000725459 - Slope : -0.0389839 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.596433 - Final Residual ratio : 0.00040969 - Residual ratio : 0.0006869 - Slope : -0.0350602 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.532337 - Final Residual ratio : 0.000310971 - Residual ratio : 0.000584161 - Slope : -0.0312957 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.483312 - Final Residual ratio : 0.000372047 - Residual ratio : 0.000769786 - Slope : -0.032196 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.1096 - Final Residual ratio : 0.0505571 - Residual ratio : 0.000776493 - Slope : -4.33727 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7291 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.6226 - Final Residual ratio : 0.0190064 - Residual ratio : 0.000688074 - Slope : -1.84024 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.01186 - Final Residual ratio : 0.00420544 - Residual ratio : 0.000839098 - Slope : -0.312978 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.33001 - Final Residual ratio : 0.00398312 - Residual ratio : 0.000919886 - Slope : -0.270377 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.87793 - Final Residual ratio : 0.00457153 - Residual ratio : 0.000937187 - Slope : -0.324891 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.3369 - Final Residual ratio : 0.0135255 - Residual ratio : 0.00047731 - Slope : -1.66608 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7341 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.7705 - Final Residual ratio : 0.0140571 - Residual ratio : 0.000711015 - Slope : -1.41117 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5898 - Final Residual ratio : 0.0120215 - Residual ratio : 0.000724633 - Slope : -1.18413 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.36999 - Final Residual ratio : 0.00159281 - Residual ratio : 0.000672078 - Slope : -0.148025 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49598 - Final Residual ratio : 0.000447867 - Residual ratio : 0.00029938 - Slope : -0.115041 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56699 - Final Residual ratio : 0.000989497 - Residual ratio : 0.000631464 - Slope : -0.1044 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7391 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53535 - Final Residual ratio : 0.00122279 - Residual ratio : 0.000796425 - Slope : -0.102275 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48798 - Final Residual ratio : 0.000783251 - Residual ratio : 0.000526384 - Slope : -0.09295 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36694 - Final Residual ratio : 0.00114927 - Residual ratio : 0.000840761 - Slope : -0.136579 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21338 - Final Residual ratio : 0.000788512 - Residual ratio : 0.000649846 - Slope : -0.0808397 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.05434 - Final Residual ratio : 0.000971677 - Residual ratio : 0.000921597 - Slope : -0.0752407 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7441 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.885511 - Final Residual ratio : 0.000743166 - Residual ratio : 0.000839252 - Slope : -0.0631977 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.787007 - Final Residual ratio : 0.000437893 - Residual ratio : 0.000556403 - Slope : -0.0561835 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.703564 - Final Residual ratio : 0.000522094 - Residual ratio : 0.00074207 - Slope : -0.0413554 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.633886 - Final Residual ratio : 0.000378019 - Residual ratio : 0.000596351 - Slope : -0.0372652 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.571554 - Final Residual ratio : 0.000300022 - Residual ratio : 0.000524923 - Slope : -0.0336032 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7491 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.496899 - Final Residual ratio : 0.000429986 - Residual ratio : 0.000865339 - Slope : -0.0310293 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.46205 - Final Residual ratio : 0.000397442 - Residual ratio : 0.00086017 - Slope : -0.0288533 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.447082 - Final Residual ratio : 0.000280426 - Residual ratio : 0.000627236 - Slope : -0.0262824 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.452932 - Final Residual ratio : 0.000373037 - Residual ratio : 0.000823605 - Slope : -0.0282849 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.471973 - Final Residual ratio : 0.000371795 - Residual ratio : 0.000787745 - Slope : -0.0294751 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7541 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.4541 - Final Residual ratio : 0.0507578 - Residual ratio : 0.000763802 - Slope : -4.42689 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.615 - Final Residual ratio : 0.0192618 - Residual ratio : 0.000697512 - Slope : -1.83971 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.95924 - Final Residual ratio : 0.00241949 - Residual ratio : 0.000487875 - Slope : -0.309801 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.36016 - Final Residual ratio : 0.00319832 - Residual ratio : 0.000733534 - Slope : -0.27231 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.89786 - Final Residual ratio : 0.00295876 - Residual ratio : 0.000604093 - Slope : -0.326327 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7591 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.5352 - Final Residual ratio : 0.0138104 - Residual ratio : 0.000483977 - Slope : -1.67773 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9478 - Final Residual ratio : 0.0114768 - Residual ratio : 0.000575344 - Slope : -1.42402 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5597 - Final Residual ratio : 0.0121803 - Residual ratio : 0.000735537 - Slope : -1.18197 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.43748 - Final Residual ratio : 0.00157506 - Residual ratio : 0.000646183 - Slope : -0.173994 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.58245 - Final Residual ratio : 0.000743066 - Residual ratio : 0.000469567 - Slope : -0.12167 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7641 -dimension in distance computation 2 -elements_to_solve.size() : 49 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61573 - Final Residual ratio : 0.00158709 - Residual ratio : 0.000982272 - Slope : -0.10761 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63641 - Final Residual ratio : 0.00134982 - Residual ratio : 0.000824866 - Slope : -0.102192 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56945 - Final Residual ratio : 0.00133404 - Residual ratio : 0.000850002 - Slope : -0.0980073 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.9954 - Final Residual ratio : 0.0121211 - Residual ratio : 0.000638106 - Slope : -1.35595 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 7.39196 - Final Residual ratio : 0.00736436 - Residual ratio : 0.000996266 - Slope : -0.738459 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7691 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.43478 - Final Residual ratio : 0.00369992 - Residual ratio : 0.000834298 - Slope : -0.316505 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38968 - Final Residual ratio : 0.000931839 - Residual ratio : 0.000670541 - Slope : -0.0925834 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.10919 - Final Residual ratio : 0.000707518 - Residual ratio : 0.000637869 - Slope : -0.0692802 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.03289 - Final Residual ratio : 0.000683988 - Residual ratio : 0.000662205 - Slope : -0.0645131 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.00545 - Final Residual ratio : 0.000719687 - Residual ratio : 0.000715788 - Slope : -0.0627955 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7741 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.952782 - Final Residual ratio : 0.000768181 - Residual ratio : 0.00080625 - Slope : -0.0595009 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.952126 - Final Residual ratio : 0.000901757 - Residual ratio : 0.000947098 - Slope : -0.0594515 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.910279 - Final Residual ratio : 0.000573007 - Residual ratio : 0.000629484 - Slope : -0.0827006 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.858807 - Final Residual ratio : 0.000650279 - Residual ratio : 0.000757189 - Slope : -0.0572104 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.811041 - Final Residual ratio : 0.000608665 - Residual ratio : 0.000750474 - Slope : -0.0578881 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7791 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.4632 - Final Residual ratio : 0.0506446 - Residual ratio : 0.000761995 - Slope : -4.4275 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.5801 - Final Residual ratio : 0.0180324 - Residual ratio : 0.000653819 - Slope : -1.83747 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.97552 - Final Residual ratio : 0.00420253 - Residual ratio : 0.000844641 - Slope : -0.451938 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.47567 - Final Residual ratio : 0.00385946 - Residual ratio : 0.000862319 - Slope : -0.279488 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.97901 - Final Residual ratio : 0.0043613 - Residual ratio : 0.000875937 - Slope : -0.331643 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7841 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.6153 - Final Residual ratio : 0.0137124 - Residual ratio : 0.000479198 - Slope : -1.68245 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9166 - Final Residual ratio : 0.0128337 - Residual ratio : 0.000644371 - Slope : -1.4217 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5462 - Final Residual ratio : 0.0102771 - Residual ratio : 0.000621117 - Slope : -1.18114 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.41445 - Final Residual ratio : 0.00186074 - Residual ratio : 0.000770669 - Slope : -0.150787 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55268 - Final Residual ratio : 0.00100472 - Residual ratio : 0.000647085 - Slope : -0.119359 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7891 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.59063 - Final Residual ratio : 0.000654045 - Residual ratio : 0.000411185 - Slope : -0.122306 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5886 - Final Residual ratio : 0.00135719 - Residual ratio : 0.000854333 - Slope : -0.105816 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.50841 - Final Residual ratio : 0.000920099 - Residual ratio : 0.000609978 - Slope : -0.0942183 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37386 - Final Residual ratio : 0.000862828 - Residual ratio : 0.000628033 - Slope : -0.0858121 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21118 - Final Residual ratio : 0.000830879 - Residual ratio : 0.000686009 - Slope : -0.0756466 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7941 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01339 - Final Residual ratio : 0.000531819 - Residual ratio : 0.00052479 - Slope : -0.0675242 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.885047 - Final Residual ratio : 0.000823379 - Residual ratio : 0.000930323 - Slope : -0.0631588 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.772264 - Final Residual ratio : 0.000575802 - Residual ratio : 0.000745603 - Slope : -0.0551206 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.686827 - Final Residual ratio : 0.000407479 - Residual ratio : 0.000593278 - Slope : -0.0403776 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.623195 - Final Residual ratio : 0.000362921 - Residual ratio : 0.000582355 - Slope : -0.0366372 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.7991 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.56312 - Final Residual ratio : 0.000417868 - Residual ratio : 0.000742059 - Slope : -0.0331001 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.509681 - Final Residual ratio : 0.000308106 - Residual ratio : 0.000604509 - Slope : -0.0299631 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.464624 - Final Residual ratio : 0.000459287 - Residual ratio : 0.000988513 - Slope : -0.0273038 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.430481 - Final Residual ratio : 0.000278723 - Residual ratio : 0.000647468 - Slope : -0.0268876 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.420404 - Final Residual ratio : 0.000214996 - Residual ratio : 0.000511402 - Slope : -0.024717 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8041 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.4532 - Final Residual ratio : 0.0515183 - Residual ratio : 0.000775257 - Slope : -4.42678 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.571 - Final Residual ratio : 0.0189589 - Residual ratio : 0.00068764 - Slope : -1.8368 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.93177 - Final Residual ratio : 0.00346064 - Residual ratio : 0.000701703 - Slope : -0.30802 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.3995 - Final Residual ratio : 0.00371917 - Residual ratio : 0.000845363 - Slope : -0.274736 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.91647 - Final Residual ratio : 0.00403797 - Residual ratio : 0.000821315 - Slope : -0.327495 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8091 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.5814 - Final Residual ratio : 0.013891 - Residual ratio : 0.000486016 - Slope : -1.68044 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.9119 - Final Residual ratio : 0.0134091 - Residual ratio : 0.000673423 - Slope : -1.42132 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5339 - Final Residual ratio : 0.0126817 - Residual ratio : 0.000767015 - Slope : -1.18009 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.38471 - Final Residual ratio : 0.00169885 - Residual ratio : 0.000712392 - Slope : -0.158868 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51995 - Final Residual ratio : 0.000662489 - Residual ratio : 0.000435863 - Slope : -0.116868 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8141 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56844 - Final Residual ratio : 0.00152982 - Residual ratio : 0.000975376 - Slope : -0.111922 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.58789 - Final Residual ratio : 0.00112751 - Residual ratio : 0.000710065 - Slope : -0.0991728 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.51955 - Final Residual ratio : 0.00106156 - Residual ratio : 0.000698601 - Slope : -0.0949055 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38864 - Final Residual ratio : 0.00113279 - Residual ratio : 0.000815749 - Slope : -0.0867195 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2212 - Final Residual ratio : 0.000786816 - Residual ratio : 0.000644295 - Slope : -0.0762761 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8191 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01975 - Final Residual ratio : 0.000783031 - Residual ratio : 0.000767865 - Slope : -0.0727834 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.876284 - Final Residual ratio : 0.000655433 - Residual ratio : 0.000747969 - Slope : -0.0583753 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.758903 - Final Residual ratio : 0.00059163 - Residual ratio : 0.000779586 - Slope : -0.0473944 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.679114 - Final Residual ratio : 0.00060804 - Residual ratio : 0.000895344 - Slope : -0.0399121 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.627886 - Final Residual ratio : 0.0004755 - Residual ratio : 0.000757303 - Slope : -0.0369065 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8241 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.585226 - Final Residual ratio : 0.000486237 - Residual ratio : 0.000830853 - Slope : -0.0343965 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.535857 - Final Residual ratio : 0.0001619 - Residual ratio : 0.000302133 - Slope : -0.0243498 - Tolerance : 0.001 - Number of iterations : 22 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.493559 - Final Residual ratio : 0.000251669 - Residual ratio : 0.000509907 - Slope : -0.0308317 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.459696 - Final Residual ratio : 0.000422462 - Residual ratio : 0.000919003 - Slope : -0.0287046 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.448901 - Final Residual ratio : 0.000251809 - Residual ratio : 0.000560945 - Slope : -0.0263911 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8291 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.427092 - Final Residual ratio : 0.000416182 - Residual ratio : 0.000974456 - Slope : -0.0266672 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.6454 - Final Residual ratio : 0.0501601 - Residual ratio : 0.000752642 - Slope : -4.43968 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.4807 - Final Residual ratio : 0.018628 - Residual ratio : 0.00067786 - Slope : -1.8308 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.90894 - Final Residual ratio : 0.00297107 - Residual ratio : 0.000605238 - Slope : -0.306623 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.42465 - Final Residual ratio : 0.00368686 - Residual ratio : 0.000833254 - Slope : -0.27631 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8341 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.90547 - Final Residual ratio : 0.00353488 - Residual ratio : 0.0007206 - Slope : -0.326796 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.77369 - Final Residual ratio : 0.00420747 - Residual ratio : 0.000881388 - Slope : -0.340677 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.734 - Final Residual ratio : 0.0125589 - Residual ratio : 0.000469773 - Slope : -1.57185 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.0971 - Final Residual ratio : 0.0104086 - Residual ratio : 0.000545037 - Slope : -1.36333 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2633 - Final Residual ratio : 0.0110313 - Residual ratio : 0.000678291 - Slope : -1.80581 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8391 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.78834 - Final Residual ratio : 0.00204459 - Residual ratio : 0.000733264 - Slope : -0.174143 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.91623 - Final Residual ratio : 0.00101923 - Residual ratio : 0.000531895 - Slope : -0.147324 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8537 - Final Residual ratio : 0.00149184 - Residual ratio : 0.000804792 - Slope : -0.123481 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76964 - Final Residual ratio : 0.00137536 - Residual ratio : 0.000777194 - Slope : -0.110517 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63688 - Final Residual ratio : 0.00130499 - Residual ratio : 0.000797241 - Slope : -0.102224 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8441 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.4241 - Final Residual ratio : 0.000970082 - Residual ratio : 0.00068119 - Slope : -0.0889456 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26049 - Final Residual ratio : 0.000797215 - Residual ratio : 0.000632462 - Slope : -0.0787311 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08179 - Final Residual ratio : 0.00093326 - Residual ratio : 0.000862703 - Slope : -0.0772037 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.930646 - Final Residual ratio : 0.000482847 - Residual ratio : 0.00051883 - Slope : -0.0581352 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.825732 - Final Residual ratio : 0.000673313 - Residual ratio : 0.000815413 - Slope : -0.0485328 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8491 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.766354 - Final Residual ratio : 0.000565416 - Residual ratio : 0.0007378 - Slope : -0.0450464 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.711375 - Final Residual ratio : 0.000553951 - Residual ratio : 0.000778704 - Slope : -0.041813 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.660754 - Final Residual ratio : 0.00046676 - Residual ratio : 0.000706405 - Slope : -0.0388404 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.597714 - Final Residual ratio : 0.000421526 - Residual ratio : 0.00070523 - Slope : -0.0351349 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.537053 - Final Residual ratio : 0.000282975 - Residual ratio : 0.000526903 - Slope : -0.0335481 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8541 -dimension in distance computation 2 -elements_to_solve.size() : 48 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.2252 - Final Residual ratio : 0.0511914 - Residual ratio : 0.000784842 - Slope : -4.34493 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.356 - Final Residual ratio : 0.0183759 - Residual ratio : 0.00067173 - Slope : -1.82251 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.694 - Final Residual ratio : 0.0195168 - Residual ratio : 0.000899638 - Slope : -1.97041 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.0328 - Final Residual ratio : 0.00850422 - Residual ratio : 0.000847639 - Slope : -0.668289 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.51275 - Final Residual ratio : 0.00487504 - Residual ratio : 0.000884321 - Slope : -0.344242 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8591 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.61335 - Final Residual ratio : 0.0041063 - Residual ratio : 0.000731524 - Slope : -0.350578 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.6868 - Final Residual ratio : 0.0124272 - Residual ratio : 0.000465668 - Slope : -1.56908 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.1663 - Final Residual ratio : 0.0141811 - Residual ratio : 0.0007399 - Slope : -1.36801 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5938 - Final Residual ratio : 0.0142079 - Residual ratio : 0.000856219 - Slope : -1.27535 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.84078 - Final Residual ratio : 0.00472313 - Residual ratio : 0.000975697 - Slope : -0.345432 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8641 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.69604 - Final Residual ratio : 0.00234644 - Residual ratio : 0.000499663 - Slope : -0.335264 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.64389 - Final Residual ratio : 0.00247847 - Residual ratio : 0.000533707 - Slope : -0.331529 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.29656 - Final Residual ratio : 0.00340221 - Residual ratio : 0.000791845 - Slope : -0.306654 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.69084 - Final Residual ratio : 0.00291918 - Residual ratio : 0.000790924 - Slope : -0.368792 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.91986 - Final Residual ratio : 0.00142242 - Residual ratio : 0.000487155 - Slope : -0.194562 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8691 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.12352 - Final Residual ratio : 0.000733053 - Residual ratio : 0.000345206 - Slope : -0.141519 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63673 - Final Residual ratio : 0.000645888 - Residual ratio : 0.000394621 - Slope : -0.116863 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.74994 - Final Residual ratio : 0.00135151 - Residual ratio : 0.000772317 - Slope : -0.134507 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.27905 - Final Residual ratio : 0.00158977 - Residual ratio : 0.000697559 - Slope : -0.151831 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.84976 - Final Residual ratio : 0.00181887 - Residual ratio : 0.000638256 - Slope : -0.189863 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8741 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.27486 - Final Residual ratio : 0.00300951 - Residual ratio : 0.000918975 - Slope : -0.327185 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.50063 - Final Residual ratio : 0.00335232 - Residual ratio : 0.000957632 - Slope : -0.269021 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.4966 - Final Residual ratio : 0.00178883 - Residual ratio : 0.000511591 - Slope : -0.24963 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.27434 - Final Residual ratio : 0.00229447 - Residual ratio : 0.000700744 - Slope : -0.251696 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.87052 - Final Residual ratio : 0.00175107 - Residual ratio : 0.000610017 - Slope : -0.204912 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8791 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.0679 - Final Residual ratio : 0.0501002 - Residual ratio : 0.000769969 - Slope : -4.33452 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.2914 - Final Residual ratio : 0.0190827 - Residual ratio : 0.000699219 - Slope : -1.81815 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.10424 - Final Residual ratio : 0.0041346 - Residual ratio : 0.000810033 - Slope : -0.318756 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.46745 - Final Residual ratio : 0.00360861 - Residual ratio : 0.000807757 - Slope : -0.27899 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.96665 - Final Residual ratio : 0.00450444 - Residual ratio : 0.000906937 - Slope : -0.33081 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8841 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.02958 - Final Residual ratio : 0.00502371 - Residual ratio : 0.000998832 - Slope : -0.358897 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.4464 - Final Residual ratio : 0.0125748 - Residual ratio : 0.000475482 - Slope : -1.55493 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.0456 - Final Residual ratio : 0.0121429 - Residual ratio : 0.00063757 - Slope : -1.35953 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3175 - Final Residual ratio : 0.00768914 - Residual ratio : 0.000471219 - Slope : -1.81221 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.34185 - Final Residual ratio : 0.00284426 - Residual ratio : 0.000851106 - Slope : -0.2226 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8891 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.55279 - Final Residual ratio : 0.00225123 - Residual ratio : 0.000881871 - Slope : -0.196195 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.28488 - Final Residual ratio : 0.00133592 - Residual ratio : 0.000584678 - Slope : -0.152236 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00423 - Final Residual ratio : 0.00154476 - Residual ratio : 0.000770749 - Slope : -0.125168 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75568 - Final Residual ratio : 0.00147948 - Residual ratio : 0.00084268 - Slope : -0.109638 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.60526 - Final Residual ratio : 0.00151303 - Residual ratio : 0.000942544 - Slope : -0.100234 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8941 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56049 - Final Residual ratio : 0.000690844 - Residual ratio : 0.000442709 - Slope : -0.0974875 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65429 - Final Residual ratio : 0.00102592 - Residual ratio : 0.000620158 - Slope : -0.110218 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.76115 - Final Residual ratio : 0.00108022 - Residual ratio : 0.000613358 - Slope : -0.117338 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82569 - Final Residual ratio : 0.000932038 - Residual ratio : 0.000510514 - Slope : -0.140366 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81072 - Final Residual ratio : 0.00171873 - Residual ratio : 0.000949198 - Slope : -0.1206 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.8991 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.69687 - Final Residual ratio : 0.00157842 - Residual ratio : 0.000930196 - Slope : -0.105955 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.49953 - Final Residual ratio : 0.00113551 - Residual ratio : 0.000757246 - Slope : -0.0936496 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.24371 - Final Residual ratio : 0.00107288 - Residual ratio : 0.000862646 - Slope : -0.0828425 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.975772 - Final Residual ratio : 0.000512723 - Residual ratio : 0.000525454 - Slope : -0.0609537 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.783091 - Final Residual ratio : 0.000676449 - Residual ratio : 0.00086382 - Slope : -0.0558867 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9041 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.9676 - Final Residual ratio : 0.0497721 - Residual ratio : 0.000766106 - Slope : -4.32786 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.1246 - Final Residual ratio : 0.0180415 - Residual ratio : 0.000665135 - Slope : -1.8071 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.03643 - Final Residual ratio : 0.00332291 - Residual ratio : 0.000659775 - Slope : -0.296065 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.53212 - Final Residual ratio : 0.00401604 - Residual ratio : 0.000886129 - Slope : -0.283006 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.95514 - Final Residual ratio : 0.00333607 - Residual ratio : 0.000673254 - Slope : -0.309488 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9091 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.88457 - Final Residual ratio : 0.00465826 - Residual ratio : 0.00095367 - Slope : -0.348565 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 38.1392 - Final Residual ratio : 0.0275598 - Residual ratio : 0.000722611 - Slope : -2.38198 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 21.8889 - Final Residual ratio : 0.0119305 - Residual ratio : 0.000545051 - Slope : -1.45846 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.5151 - Final Residual ratio : 0.01461 - Residual ratio : 0.000884646 - Slope : -1.17861 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.86229 - Final Residual ratio : 0.00257213 - Residual ratio : 0.000665959 - Slope : -0.241232 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9141 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.02018 - Final Residual ratio : 0.00265087 - Residual ratio : 0.000659392 - Slope : -0.267835 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.51893 - Final Residual ratio : 0.00275673 - Residual ratio : 0.000610041 - Slope : -0.301078 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.93212 - Final Residual ratio : 0.00332232 - Residual ratio : 0.00067361 - Slope : -0.328586 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.2377 - Final Residual ratio : 0.00455763 - Residual ratio : 0.000870158 - Slope : -0.348876 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.35665 - Final Residual ratio : 0.0040419 - Residual ratio : 0.000754559 - Slope : -0.35684 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9191 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.20362 - Final Residual ratio : 0.004774 - Residual ratio : 0.000917438 - Slope : -0.519885 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.74987 - Final Residual ratio : 0.00469391 - Residual ratio : 0.000988219 - Slope : -0.338941 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.00072 - Final Residual ratio : 0.00231953 - Residual ratio : 0.00057978 - Slope : -0.307569 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.0548 - Final Residual ratio : 0.00188827 - Residual ratio : 0.000618133 - Slope : -0.203527 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.14736 - Final Residual ratio : 0.00105857 - Residual ratio : 0.000492963 - Slope : -0.143086 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9241 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.81534 - Final Residual ratio : 0.00173419 - Residual ratio : 0.000955301 - Slope : -0.11335 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.34713 - Final Residual ratio : 0.00206155 - Residual ratio : 0.000878329 - Slope : -0.156338 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.20472 - Final Residual ratio : 0.00213481 - Residual ratio : 0.000666146 - Slope : -0.213506 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.94961 - Final Residual ratio : 0.00230708 - Residual ratio : 0.000584129 - Slope : -0.493413 - Tolerance : 0.001 - Number of iterations : 8 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.40754 - Final Residual ratio : 0.00422415 - Residual ratio : 0.000958391 - Slope : -0.338717 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9291 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.0009 - Final Residual ratio : 0.050688 - Residual ratio : 0.000779804 - Slope : -4.33002 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.433 - Final Residual ratio : 0.0195788 - Residual ratio : 0.000713694 - Slope : -1.82756 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.13616 - Final Residual ratio : 0.00529918 - Residual ratio : 0.000863598 - Slope : -0.471605 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.19026 - Final Residual ratio : 0.0046789 - Residual ratio : 0.000901477 - Slope : -0.345705 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.17903 - Final Residual ratio : 0.00494101 - Residual ratio : 0.000954041 - Slope : -0.344939 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9341 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.96351 - Final Residual ratio : 0.00259621 - Residual ratio : 0.000523059 - Slope : -0.330727 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.3822 - Final Residual ratio : 0.0126901 - Residual ratio : 0.000481012 - Slope : -1.55114 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.0323 - Final Residual ratio : 0.0171725 - Residual ratio : 0.00090228 - Slope : -1.35822 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.4111 - Final Residual ratio : 0.0108262 - Residual ratio : 0.000659685 - Slope : -1.64003 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.37043 - Final Residual ratio : 0.00320376 - Residual ratio : 0.000733054 - Slope : -0.291149 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9391 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.02049 - Final Residual ratio : 0.0020248 - Residual ratio : 0.000503619 - Slope : -0.287034 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.79491 - Final Residual ratio : 0.00163871 - Residual ratio : 0.000431817 - Slope : -0.270948 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.31683 - Final Residual ratio : 0.00205992 - Residual ratio : 0.00062105 - Slope : -0.236769 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.66352 - Final Residual ratio : 0.00215148 - Residual ratio : 0.000807758 - Slope : -0.177424 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.00647 - Final Residual ratio : 0.000814595 - Residual ratio : 0.000405984 - Slope : -0.111425 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9441 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63769 - Final Residual ratio : 0.00113392 - Residual ratio : 0.000692391 - Slope : -0.102284 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84727 - Final Residual ratio : 0.000862201 - Residual ratio : 0.000466742 - Slope : -0.115401 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.36039 - Final Residual ratio : 0.0021505 - Residual ratio : 0.000911081 - Slope : -0.168445 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.85298 - Final Residual ratio : 0.00153987 - Residual ratio : 0.00053974 - Slope : -0.219342 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.1644 - Final Residual ratio : 0.00272644 - Residual ratio : 0.000861598 - Slope : -0.225834 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9491 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.22402 - Final Residual ratio : 0.00305667 - Residual ratio : 0.00094809 - Slope : -0.214731 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.0342 - Final Residual ratio : 0.00181696 - Residual ratio : 0.000598826 - Slope : -0.202159 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.61878 - Final Residual ratio : 0.00189149 - Residual ratio : 0.000722279 - Slope : -0.186921 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.05236 - Final Residual ratio : 0.00162307 - Residual ratio : 0.00079083 - Slope : -0.136716 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.47812 - Final Residual ratio : 0.00130419 - Residual ratio : 0.000882331 - Slope : -0.105487 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9541 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.8179 - Final Residual ratio : 0.0495948 - Residual ratio : 0.000765139 - Slope : -4.31789 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.0489 - Final Residual ratio : 0.01813 - Residual ratio : 0.000670269 - Slope : -1.80205 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.24756 - Final Residual ratio : 0.0049954 - Residual ratio : 0.000951947 - Slope : -0.436881 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.8865 - Final Residual ratio : 0.00438138 - Residual ratio : 0.000896631 - Slope : -0.305132 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.36375 - Final Residual ratio : 0.00377465 - Residual ratio : 0.000703733 - Slope : -0.334998 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9591 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.33141 - Final Residual ratio : 0.00468147 - Residual ratio : 0.000878091 - Slope : -0.355115 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.3468 - Final Residual ratio : 0.0124495 - Residual ratio : 0.000472524 - Slope : -1.54908 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.9372 - Final Residual ratio : 0.0111021 - Residual ratio : 0.000586258 - Slope : -1.35186 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.1455 - Final Residual ratio : 0.0155921 - Residual ratio : 0.000965723 - Slope : -1.24076 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.77991 - Final Residual ratio : 0.00172984 - Residual ratio : 0.000622264 - Slope : -0.173637 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9641 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.96618 - Final Residual ratio : 0.000716487 - Residual ratio : 0.000364405 - Slope : -0.131031 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.07885 - Final Residual ratio : 0.00144475 - Residual ratio : 0.000694977 - Slope : -0.138494 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.31073 - Final Residual ratio : 0.002183 - Residual ratio : 0.00094472 - Slope : -0.153903 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.51346 - Final Residual ratio : 0.00207166 - Residual ratio : 0.000824226 - Slope : -0.167426 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.60867 - Final Residual ratio : 0.00109419 - Residual ratio : 0.000419444 - Slope : -0.162974 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9691 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.53739 - Final Residual ratio : 0.0015505 - Residual ratio : 0.00061106 - Slope : -0.15849 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.34745 - Final Residual ratio : 0.000912554 - Residual ratio : 0.000388743 - Slope : -0.16761 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.01898 - Final Residual ratio : 0.00187234 - Residual ratio : 0.000927366 - Slope : -0.155162 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61516 - Final Residual ratio : 0.00120069 - Residual ratio : 0.000743392 - Slope : -0.12415 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.23832 - Final Residual ratio : 0.00110346 - Residual ratio : 0.000891088 - Slope : -0.0824814 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9741 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.04601 - Final Residual ratio : 0.000743407 - Residual ratio : 0.000710708 - Slope : -0.0653291 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.15531 - Final Residual ratio : 0.00059421 - Residual ratio : 0.000514327 - Slope : -0.07217 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42282 - Final Residual ratio : 0.000546831 - Residual ratio : 0.000384329 - Slope : -0.083663 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.67621 - Final Residual ratio : 0.00145428 - Residual ratio : 0.000867601 - Slope : -0.128827 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82879 - Final Residual ratio : 0.00143348 - Residual ratio : 0.000783841 - Slope : -0.121824 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9791 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.8049 - Final Residual ratio : 0.0500389 - Residual ratio : 0.000772147 - Slope : -4.31699 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.0187 - Final Residual ratio : 0.01856 - Residual ratio : 0.000686931 - Slope : -1.80001 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.12259 - Final Residual ratio : 0.00416423 - Residual ratio : 0.000812916 - Slope : -0.426535 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.49038 - Final Residual ratio : 0.00351668 - Residual ratio : 0.000783159 - Slope : -0.280429 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.82226 - Final Residual ratio : 0.00361408 - Residual ratio : 0.000749459 - Slope : -0.321243 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9841 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.74835 - Final Residual ratio : 0.00375324 - Residual ratio : 0.00079043 - Slope : -0.338899 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.256 - Final Residual ratio : 0.0260449 - Residual ratio : 0.00099196 - Slope : -1.63937 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.849 - Final Residual ratio : 0.0123859 - Residual ratio : 0.000657113 - Slope : -1.34548 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.1159 - Final Residual ratio : 0.0122472 - Residual ratio : 0.000759943 - Slope : -1.15026 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.02998 - Final Residual ratio : 0.00233308 - Residual ratio : 0.000769998 - Slope : -0.189228 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9891 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.40018 - Final Residual ratio : 0.00161237 - Residual ratio : 0.000671769 - Slope : -0.171326 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.29791 - Final Residual ratio : 0.00172317 - Residual ratio : 0.000749885 - Slope : -0.153079 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.1097 - Final Residual ratio : 0.00125167 - Residual ratio : 0.000593291 - Slope : -0.131778 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.84948 - Final Residual ratio : 0.00137161 - Residual ratio : 0.000741616 - Slope : -0.115507 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.58035 - Final Residual ratio : 0.0012256 - Residual ratio : 0.000775526 - Slope : -0.0986953 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9941 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35156 - Final Residual ratio : 0.00133982 - Residual ratio : 0.000991313 - Slope : -0.0843887 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.30184 - Final Residual ratio : 0.0011641 - Residual ratio : 0.000894193 - Slope : -0.0867118 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.35184 - Final Residual ratio : 0.001015 - Residual ratio : 0.000750823 - Slope : -0.0900553 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43608 - Final Residual ratio : 0.00109799 - Residual ratio : 0.000764574 - Slope : -0.102499 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48243 - Final Residual ratio : 0.00102212 - Residual ratio : 0.000689489 - Slope : -0.0987605 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 1.9991 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.44443 - Final Residual ratio : 0.0011671 - Residual ratio : 0.000808 - Slope : -0.0962178 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31789 - Final Residual ratio : 0.00131438 - Residual ratio : 0.00099733 - Slope : -0.087772 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1134 - Final Residual ratio : 0.00101503 - Residual ratio : 0.000911653 - Slope : -0.111238 - Tolerance : 0.001 - Number of iterations : 10 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.87339 - Final Residual ratio : 0.000830954 - Residual ratio : 0.000951413 - Slope : -0.0581706 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -writing a 2D mesh -0.001 -******** CURRENT TIME = 2.0031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.688344 - Final Residual ratio : 0.000542054 - Residual ratio : 0.000787474 - Slope : -0.0429876 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0041 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.7391 - Final Residual ratio : 0.050575 - Residual ratio : 0.000781212 - Slope : -4.31257 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.9385 - Final Residual ratio : 0.0188128 - Residual ratio : 0.000698361 - Slope : -1.79465 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.00885 - Final Residual ratio : 0.00449803 - Residual ratio : 0.000898017 - Slope : -0.38495 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.48634 - Final Residual ratio : 0.00350671 - Residual ratio : 0.000781642 - Slope : -0.280177 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.88831 - Final Residual ratio : 0.00449496 - Residual ratio : 0.000919532 - Slope : -0.325588 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0091 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.9416 - Final Residual ratio : 0.0135119 - Residual ratio : 0.000483575 - Slope : -1.64283 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.6026 - Final Residual ratio : 0.013922 - Residual ratio : 0.000710214 - Slope : -1.39919 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3145 - Final Residual ratio : 0.0126143 - Residual ratio : 0.000773192 - Slope : -1.16442 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.39974 - Final Residual ratio : 0.00154203 - Residual ratio : 0.000642582 - Slope : -0.15988 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52904 - Final Residual ratio : 0.00131118 - Residual ratio : 0.00085752 - Slope : -0.109123 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0141 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56774 - Final Residual ratio : 0.0012822 - Residual ratio : 0.000817868 - Slope : -0.11189 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.62703 - Final Residual ratio : 0.00160081 - Residual ratio : 0.000983884 - Slope : -0.108362 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64377 - Final Residual ratio : 0.00094813 - Residual ratio : 0.000576802 - Slope : -0.102676 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61136 - Final Residual ratio : 0.00139756 - Residual ratio : 0.000867316 - Slope : -0.107331 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52759 - Final Residual ratio : 0.00117369 - Residual ratio : 0.000768329 - Slope : -0.169602 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0191 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.37331 - Final Residual ratio : 0.000609819 - Residual ratio : 0.000444051 - Slope : -0.0915133 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21571 - Final Residual ratio : 0.00111033 - Residual ratio : 0.000913318 - Slope : -0.0867571 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02579 - Final Residual ratio : 0.000578734 - Residual ratio : 0.000564183 - Slope : -0.0683476 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.842511 - Final Residual ratio : 0.000707335 - Residual ratio : 0.000839555 - Slope : -0.0561203 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.713364 - Final Residual ratio : 0.000550499 - Residual ratio : 0.000771695 - Slope : -0.0419302 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0241 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.676239 - Final Residual ratio : 0.000675649 - Residual ratio : 0.000999127 - Slope : -0.0422227 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.732822 - Final Residual ratio : 0.000395118 - Residual ratio : 0.000539173 - Slope : -0.043084 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.830254 - Final Residual ratio : 0.000521935 - Residual ratio : 0.000628645 - Slope : -0.0518583 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.915042 - Final Residual ratio : 0.000643756 - Residual ratio : 0.000703525 - Slope : -0.0653142 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.960722 - Final Residual ratio : 0.000912708 - Residual ratio : 0.000950023 - Slope : -0.0639873 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0291 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.944046 - Final Residual ratio : 0.000636841 - Residual ratio : 0.000674587 - Slope : -0.0589631 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.892706 - Final Residual ratio : 0.000470886 - Residual ratio : 0.000527481 - Slope : -0.0557647 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.2493 - Final Residual ratio : 0.0497013 - Residual ratio : 0.000750216 - Slope : -4.41331 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.0025 - Final Residual ratio : 0.0184485 - Residual ratio : 0.000683215 - Slope : -1.79894 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.86991 - Final Residual ratio : 0.00288192 - Residual ratio : 0.000591781 - Slope : -0.304189 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0341 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.38319 - Final Residual ratio : 0.00372815 - Residual ratio : 0.000850556 - Slope : -0.273717 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.81578 - Final Residual ratio : 0.00339784 - Residual ratio : 0.000705563 - Slope : -0.320826 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.1752 - Final Residual ratio : 0.0135104 - Residual ratio : 0.000479515 - Slope : -1.65657 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.6954 - Final Residual ratio : 0.0117953 - Residual ratio : 0.000598885 - Slope : -1.40597 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.3023 - Final Residual ratio : 0.0126063 - Residual ratio : 0.000773284 - Slope : -1.16355 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0391 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.51034 - Final Residual ratio : 0.00207008 - Residual ratio : 0.000824624 - Slope : -0.167218 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.62846 - Final Residual ratio : 0.000802485 - Residual ratio : 0.000492787 - Slope : -0.125204 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64126 - Final Residual ratio : 0.000932631 - Residual ratio : 0.000568242 - Slope : -0.117166 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.62251 - Final Residual ratio : 0.000913475 - Residual ratio : 0.000563002 - Slope : -0.10135 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55023 - Final Residual ratio : 0.00107392 - Residual ratio : 0.000692752 - Slope : -0.096822 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0441 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40099 - Final Residual ratio : 0.000671228 - Residual ratio : 0.000479109 - Slope : -0.08752 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.29977 - Final Residual ratio : 0.000853138 - Residual ratio : 0.000656377 - Slope : -0.0811822 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17885 - Final Residual ratio : 0.00109594 - Residual ratio : 0.000929667 - Slope : -0.0736095 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07096 - Final Residual ratio : 0.000681026 - Residual ratio : 0.000635902 - Slope : -0.071352 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.984815 - Final Residual ratio : 0.000743385 - Residual ratio : 0.000754847 - Slope : -0.0656048 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0491 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.919047 - Final Residual ratio : 0.000748849 - Residual ratio : 0.00081481 - Slope : -0.0612199 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.85208 - Final Residual ratio : 0.000502798 - Residual ratio : 0.000590084 - Slope : -0.0532236 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.783525 - Final Residual ratio : 0.000694461 - Residual ratio : 0.00088633 - Slope : -0.0521887 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.704141 - Final Residual ratio : 0.000314524 - Residual ratio : 0.000446677 - Slope : -0.0439892 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.627132 - Final Residual ratio : 0.000237473 - Residual ratio : 0.000378665 - Slope : -0.0368762 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0541 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.567857 - Final Residual ratio : 0.000261002 - Residual ratio : 0.000459627 - Slope : -0.0354747 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.56668 - Final Residual ratio : 0.0004601 - Residual ratio : 0.000811922 - Slope : -0.037748 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.612903 - Final Residual ratio : 0.00059432 - Residual ratio : 0.000969681 - Slope : -0.0382693 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.669024 - Final Residual ratio : 0.000572411 - Residual ratio : 0.000855591 - Slope : -0.0417782 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 66.7641 - Final Residual ratio : 0.0495893 - Residual ratio : 0.000742753 - Slope : -4.44763 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0591 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.0041 - Final Residual ratio : 0.0182359 - Residual ratio : 0.000675299 - Slope : -1.79906 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.84667 - Final Residual ratio : 0.00359298 - Residual ratio : 0.000741329 - Slope : -0.302692 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.49685 - Final Residual ratio : 0.00357262 - Residual ratio : 0.000794471 - Slope : -0.28083 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.85207 - Final Residual ratio : 0.00313677 - Residual ratio : 0.000646481 - Slope : -0.323262 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.3164 - Final Residual ratio : 0.0281477 - Residual ratio : 0.000994043 - Slope : -1.76802 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0641 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.6927 - Final Residual ratio : 0.010173 - Residual ratio : 0.000516588 - Slope : -1.40589 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.2998 - Final Residual ratio : 0.00985937 - Residual ratio : 0.000604876 - Slope : -1.16357 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.42737 - Final Residual ratio : 0.00164642 - Residual ratio : 0.000678276 - Slope : -0.173266 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.58268 - Final Residual ratio : 0.00128401 - Residual ratio : 0.000811287 - Slope : -0.121646 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.6275 - Final Residual ratio : 0.00136676 - Residual ratio : 0.000839792 - Slope : -0.125087 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0691 -dimension in distance computation 2 -elements_to_solve.size() : 52 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.59495 - Final Residual ratio : 0.000958828 - Residual ratio : 0.000601164 - Slope : -0.106266 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.54574 - Final Residual ratio : 0.000863689 - Residual ratio : 0.000558755 - Slope : -0.0965547 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42358 - Final Residual ratio : 0.00103052 - Residual ratio : 0.000723893 - Slope : -0.0889091 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.26066 - Final Residual ratio : 0.00111184 - Residual ratio : 0.000881951 - Slope : -0.0787216 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.08272 - Final Residual ratio : 0.000796973 - Residual ratio : 0.000736082 - Slope : -0.0676204 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0741 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 28.3764 - Final Residual ratio : 0.0264682 - Residual ratio : 0.000932753 - Slope : -3.14999 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 10.2603 - Final Residual ratio : 0.00778161 - Residual ratio : 0.000758423 - Slope : -0.732319 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.66998 - Final Residual ratio : 0.00285094 - Residual ratio : 0.000610482 - Slope : -0.388927 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.60975 - Final Residual ratio : 0.0030996 - Residual ratio : 0.000858675 - Slope : -0.240443 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.26219 - Final Residual ratio : 0.00222676 - Residual ratio : 0.000682597 - Slope : -0.203748 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0791 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.86499 - Final Residual ratio : 0.00384385 - Residual ratio : 0.000994531 - Slope : -0.25741 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.88323 - Final Residual ratio : 0.00365414 - Residual ratio : 0.000748304 - Slope : -0.325305 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.78511 - Final Residual ratio : 0.00533749 - Residual ratio : 0.000922627 - Slope : -0.642196 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.29895 - Final Residual ratio : 0.00397609 - Residual ratio : 0.00063123 - Slope : -0.57227 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 6.33143 - Final Residual ratio : 0.00594667 - Residual ratio : 0.000939231 - Slope : -0.527123 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0841 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.87627 - Final Residual ratio : 0.00469606 - Residual ratio : 0.000799157 - Slope : -0.45166 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 67.035 - Final Residual ratio : 0.0512278 - Residual ratio : 0.000764194 - Slope : -4.46558 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 27.2593 - Final Residual ratio : 0.0195285 - Residual ratio : 0.000716398 - Slope : -1.81598 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.47919 - Final Residual ratio : 0.00515027 - Residual ratio : 0.00093997 - Slope : -0.364936 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.86547 - Final Residual ratio : 0.00384412 - Residual ratio : 0.000790082 - Slope : -0.303851 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0891 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.26516 - Final Residual ratio : 0.00408884 - Residual ratio : 0.000776584 - Slope : -0.350738 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.5302 - Final Residual ratio : 0.00524455 - Residual ratio : 0.000948347 - Slope : -0.39464 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.8349 - Final Residual ratio : 0.0125842 - Residual ratio : 0.00046895 - Slope : -1.57778 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 19.4286 - Final Residual ratio : 0.0126786 - Residual ratio : 0.000652576 - Slope : -1.38685 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.6632 - Final Residual ratio : 0.0147994 - Residual ratio : 0.000888147 - Slope : -1.18917 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0941 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.16494 - Final Residual ratio : 0.00480373 - Residual ratio : 0.000930065 - Slope : -0.344009 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.33915 - Final Residual ratio : 0.00145101 - Residual ratio : 0.000334401 - Slope : -0.309835 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.67814 - Final Residual ratio : 0.00226399 - Residual ratio : 0.000615527 - Slope : -0.262562 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.92924 - Final Residual ratio : 0.00249917 - Residual ratio : 0.000853182 - Slope : -0.195116 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.281 - Final Residual ratio : 0.00157764 - Residual ratio : 0.000691646 - Slope : -0.142464 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.0991 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.98065 - Final Residual ratio : 0.00116546 - Residual ratio : 0.000588425 - Slope : -0.123718 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.19127 - Final Residual ratio : 0.00151479 - Residual ratio : 0.000691282 - Slope : -0.13686 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.60539 - Final Residual ratio : 0.00175617 - Residual ratio : 0.000674054 - Slope : -0.173576 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.96566 - Final Residual ratio : 0.00174322 - Residual ratio : 0.000587803 - Slope : -0.211708 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.14019 - Final Residual ratio : 0.00303645 - Residual ratio : 0.000966964 - Slope : -0.261429 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1041 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.08009 - Final Residual ratio : 0.00231119 - Residual ratio : 0.000750362 - Slope : -0.219842 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.79035 - Final Residual ratio : 0.00246169 - Residual ratio : 0.000882215 - Slope : -0.199135 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.30549 - Final Residual ratio : 0.00215887 - Residual ratio : 0.000936401 - Slope : -0.164524 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.71251 - Final Residual ratio : 0.00105556 - Residual ratio : 0.000616385 - Slope : -0.114097 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.17561 - Final Residual ratio : 0.000875463 - Residual ratio : 0.000744691 - Slope : -0.0691018 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1091 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.0661 - Final Residual ratio : 0.0515997 - Residual ratio : 0.000793035 - Slope : -4.3343 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.98 - Final Residual ratio : 0.018426 - Residual ratio : 0.00068295 - Slope : -1.79744 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.18408 - Final Residual ratio : 0.00455965 - Residual ratio : 0.000879549 - Slope : -0.470865 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.89791 - Final Residual ratio : 0.00270008 - Residual ratio : 0.000551273 - Slope : -0.287953 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.3157 - Final Residual ratio : 0.00392427 - Residual ratio : 0.000738242 - Slope : -0.331986 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1141 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 5.27203 - Final Residual ratio : 0.00418391 - Residual ratio : 0.000793604 - Slope : -0.35119 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.4213 - Final Residual ratio : 0.0123398 - Residual ratio : 0.00046704 - Slope : -1.55347 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.8564 - Final Residual ratio : 0.0142836 - Residual ratio : 0.000757489 - Slope : -1.34587 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 16.068 - Final Residual ratio : 0.00845555 - Residual ratio : 0.000526236 - Slope : -1.78439 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.70181 - Final Residual ratio : 0.0020982 - Residual ratio : 0.000776591 - Slope : -0.179981 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1191 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8932 - Final Residual ratio : 0.00103421 - Residual ratio : 0.000546278 - Slope : -0.135154 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.96166 - Final Residual ratio : 0.00135408 - Residual ratio : 0.000690271 - Slope : -0.140022 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.11023 - Final Residual ratio : 0.00108699 - Residual ratio : 0.000515105 - Slope : -0.140609 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.22458 - Final Residual ratio : 0.00137889 - Residual ratio : 0.000619843 - Slope : -0.123511 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.25095 - Final Residual ratio : 0.00120658 - Residual ratio : 0.000536029 - Slope : -0.149983 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1241 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.15063 - Final Residual ratio : 0.00180575 - Residual ratio : 0.000839641 - Slope : -0.153487 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.9608 - Final Residual ratio : 0.000951453 - Residual ratio : 0.000485237 - Slope : -0.139989 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.66701 - Final Residual ratio : 0.00151403 - Residual ratio : 0.000908227 - Slope : -0.138792 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.32328 - Final Residual ratio : 0.00127776 - Residual ratio : 0.000965598 - Slope : -0.094429 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.01359 - Final Residual ratio : 0.000809233 - Residual ratio : 0.000798384 - Slope : -0.0632987 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1291 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.856797 - Final Residual ratio : 0.000735396 - Residual ratio : 0.000858308 - Slope : -0.0503566 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.96635 - Final Residual ratio : 0.000655099 - Residual ratio : 0.000677911 - Slope : -0.0643796 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1959 - Final Residual ratio : 0.000497113 - Residual ratio : 0.000415683 - Slope : -0.0796932 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.41366 - Final Residual ratio : 0.000766472 - Residual ratio : 0.000542191 - Slope : -0.100921 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.55078 - Final Residual ratio : 0.000991431 - Residual ratio : 0.000639309 - Slope : -0.0968621 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1341 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.56723 - Final Residual ratio : 0.00137117 - Residual ratio : 0.000874904 - Slope : -0.10439 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 65.0908 - Final Residual ratio : 0.0493032 - Residual ratio : 0.000757453 - Slope : -4.3361 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.7804 - Final Residual ratio : 0.0188848 - Residual ratio : 0.000705174 - Slope : -1.7841 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.93148 - Final Residual ratio : 0.00264154 - Residual ratio : 0.000535649 - Slope : -0.308052 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.44234 - Final Residual ratio : 0.003405 - Residual ratio : 0.000766488 - Slope : -0.277433 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1391 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.74332 - Final Residual ratio : 0.00305548 - Residual ratio : 0.000644166 - Slope : -0.316017 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.62416 - Final Residual ratio : 0.00337947 - Residual ratio : 0.000730829 - Slope : -0.330056 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.27087 - Final Residual ratio : 0.00215092 - Residual ratio : 0.000503626 - Slope : -0.304909 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.5177 - Final Residual ratio : 0.0116275 - Residual ratio : 0.000474252 - Slope : -1.44153 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.1505 - Final Residual ratio : 0.0115628 - Residual ratio : 0.000637054 - Slope : -1.29564 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1441 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.8806 - Final Residual ratio : 0.0100376 - Residual ratio : 0.000632065 - Slope : -1.13361 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.18407 - Final Residual ratio : 0.00272022 - Residual ratio : 0.000854322 - Slope : -0.21209 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.31341 - Final Residual ratio : 0.00121638 - Residual ratio : 0.000525794 - Slope : -0.177861 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.07944 - Final Residual ratio : 0.00110333 - Residual ratio : 0.000530592 - Slope : -0.138556 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.87417 - Final Residual ratio : 0.00129109 - Residual ratio : 0.000688888 - Slope : -0.117055 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1491 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64915 - Final Residual ratio : 0.000994144 - Residual ratio : 0.000602823 - Slope : -0.10301 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.53717 - Final Residual ratio : 0.000912188 - Residual ratio : 0.000593419 - Slope : -0.0903684 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.45677 - Final Residual ratio : 0.00118271 - Residual ratio : 0.000811869 - Slope : -0.0970391 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.42084 - Final Residual ratio : 0.00117533 - Residual ratio : 0.000827213 - Slope : -0.0946441 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40322 - Final Residual ratio : 0.0012842 - Residual ratio : 0.000915183 - Slope : -0.107841 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1541 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.36773 - Final Residual ratio : 0.00102469 - Residual ratio : 0.000749192 - Slope : -0.0911135 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2834 - Final Residual ratio : 0.000970659 - Residual ratio : 0.00075632 - Slope : -0.0854951 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.14902 - Final Residual ratio : 0.000870107 - Residual ratio : 0.000757261 - Slope : -0.0765433 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.970115 - Final Residual ratio : 0.00054284 - Residual ratio : 0.000559563 - Slope : -0.0605983 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 63.0659 - Final Residual ratio : 0.0510434 - Residual ratio : 0.000809366 - Slope : -4.20099 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1591 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.6589 - Final Residual ratio : 0.0189299 - Residual ratio : 0.000710078 - Slope : -1.776 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.97896 - Final Residual ratio : 0.00301095 - Residual ratio : 0.000604735 - Slope : -0.310997 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.2669 - Final Residual ratio : 0.00222405 - Residual ratio : 0.000521234 - Slope : -0.250863 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.70793 - Final Residual ratio : 0.0034339 - Residual ratio : 0.000729387 - Slope : -0.294031 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.60449 - Final Residual ratio : 0.00243239 - Residual ratio : 0.000528264 - Slope : -0.306804 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1641 -dimension in distance computation 2 -elements_to_solve.size() : 55 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 3.88974 - Final Residual ratio : 0.00361834 - Residual ratio : 0.000930229 - Slope : -0.27758 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.0031 - Final Residual ratio : 0.0114593 - Residual ratio : 0.000458314 - Slope : -1.4701 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.8326 - Final Residual ratio : 0.0137355 - Residual ratio : 0.000770245 - Slope : -1.27278 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.857 - Final Residual ratio : 0.0129161 - Residual ratio : 0.000814539 - Slope : -1.76045 - Tolerance : 0.001 - Number of iterations : 9 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.75694 - Final Residual ratio : 0.00131253 - Residual ratio : 0.000476085 - Slope : -0.172226 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1691 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.92511 - Final Residual ratio : 0.00124135 - Residual ratio : 0.000644819 - Slope : -0.137419 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82998 - Final Residual ratio : 0.00153217 - Residual ratio : 0.00083726 - Slope : -0.121896 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.73595 - Final Residual ratio : 0.00106314 - Residual ratio : 0.000612425 - Slope : -0.10843 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63338 - Final Residual ratio : 0.00116167 - Residual ratio : 0.000711204 - Slope : -0.108815 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52974 - Final Residual ratio : 0.00104894 - Residual ratio : 0.000685694 - Slope : -0.101913 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1741 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.40462 - Final Residual ratio : 0.000965161 - Residual ratio : 0.000687131 - Slope : -0.0935773 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.31115 - Final Residual ratio : 0.0012912 - Residual ratio : 0.000984781 - Slope : -0.0935613 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.1972 - Final Residual ratio : 0.00105456 - Residual ratio : 0.000880848 - Slope : -0.0797434 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.0638 - Final Residual ratio : 0.000793437 - Residual ratio : 0.000745849 - Slope : -0.0664381 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.920377 - Final Residual ratio : 0.000670101 - Residual ratio : 0.000728073 - Slope : -0.0574817 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1791 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.756376 - Final Residual ratio : 0.000726195 - Residual ratio : 0.000960098 - Slope : -0.0503767 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.688988 - Final Residual ratio : 0.000420111 - Residual ratio : 0.000609752 - Slope : -0.0430355 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.677731 - Final Residual ratio : 0.000510154 - Residual ratio : 0.000752738 - Slope : -0.0483729 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.72128 - Final Residual ratio : 0.000373193 - Residual ratio : 0.000517403 - Slope : -0.0424063 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.782824 - Final Residual ratio : 0.000670417 - Residual ratio : 0.000856409 - Slope : -0.0488846 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1841 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.805646 - Final Residual ratio : 0.000740521 - Residual ratio : 0.000919164 - Slope : -0.0503066 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.818985 - Final Residual ratio : 0.000760835 - Residual ratio : 0.000928997 - Slope : -0.051139 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.3559 - Final Residual ratio : 0.0491541 - Residual ratio : 0.000763785 - Slope : -4.28712 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.5223 - Final Residual ratio : 0.0198266 - Residual ratio : 0.000747544 - Slope : -1.76683 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.88518 - Final Residual ratio : 0.00480513 - Residual ratio : 0.000983614 - Slope : -0.348598 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1891 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.25695 - Final Residual ratio : 0.00397549 - Residual ratio : 0.000933882 - Slope : -0.283531 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.60242 - Final Residual ratio : 0.00301295 - Residual ratio : 0.000654645 - Slope : -0.328529 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.50659 - Final Residual ratio : 0.0022986 - Residual ratio : 0.000510053 - Slope : -0.321735 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.8527 - Final Residual ratio : 0.0122665 - Residual ratio : 0.000474477 - Slope : -1.52002 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.6845 - Final Residual ratio : 0.0111587 - Residual ratio : 0.000597219 - Slope : -1.33381 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1941 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.862 - Final Residual ratio : 0.0117497 - Residual ratio : 0.000740746 - Slope : -1.13216 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.64176 - Final Residual ratio : 0.00249389 - Residual ratio : 0.000944027 - Slope : -0.175951 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.88668 - Final Residual ratio : 0.00188067 - Residual ratio : 0.000996814 - Slope : -0.144984 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.86694 - Final Residual ratio : 0.0011897 - Residual ratio : 0.00063725 - Slope : -0.116609 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.82291 - Final Residual ratio : 0.00175389 - Residual ratio : 0.00096214 - Slope : -0.113822 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.1991 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.68156 - Final Residual ratio : 0.00137981 - Residual ratio : 0.000820553 - Slope : -0.105011 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.5632 - Final Residual ratio : 0.000691 - Residual ratio : 0.000442043 - Slope : -0.0919121 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.38954 - Final Residual ratio : 0.000968269 - Residual ratio : 0.000696829 - Slope : -0.0925712 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21019 - Final Residual ratio : 0.00112895 - Residual ratio : 0.000932867 - Slope : -0.0863615 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06038 - Final Residual ratio : 0.000786326 - Residual ratio : 0.000741551 - Slope : -0.0662247 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2041 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.968231 - Final Residual ratio : 0.000573705 - Residual ratio : 0.000592529 - Slope : -0.056921 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.909123 - Final Residual ratio : 0.000788503 - Residual ratio : 0.000867323 - Slope : -0.0534314 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.873774 - Final Residual ratio : 0.000640215 - Residual ratio : 0.0007327 - Slope : -0.0513608 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.829146 - Final Residual ratio : 0.000671835 - Residual ratio : 0.000810273 - Slope : -0.0487338 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2081 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.76766 - Final Residual ratio : 0.000442424 - Residual ratio : 0.000576328 - Slope : -0.0403799 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2091 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.683592 - Final Residual ratio : 0.000374247 - Residual ratio : 0.000547471 - Slope : -0.0401893 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2101 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.650419 - Final Residual ratio : 0.000402447 - Residual ratio : 0.00061875 - Slope : -0.040626 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2111 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.4052 - Final Residual ratio : 0.0487514 - Residual ratio : 0.000756948 - Slope : -4.29043 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2121 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.4836 - Final Residual ratio : 0.0168259 - Residual ratio : 0.000635332 - Slope : -1.76445 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2131 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.90005 - Final Residual ratio : 0.00314941 - Residual ratio : 0.00064273 - Slope : -0.306056 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2141 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.47677 - Final Residual ratio : 0.00216197 - Residual ratio : 0.000482931 - Slope : -0.263212 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2151 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.76468 - Final Residual ratio : 0.00290076 - Residual ratio : 0.000608805 - Slope : -0.297611 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2161 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.60327 - Final Residual ratio : 0.00427232 - Residual ratio : 0.000928105 - Slope : -0.3285 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2171 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.9668 - Final Residual ratio : 0.011777 - Residual ratio : 0.000453541 - Slope : -1.52677 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2181 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.6122 - Final Residual ratio : 0.0103204 - Residual ratio : 0.000554497 - Slope : -1.3287 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2191 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.8365 - Final Residual ratio : 0.0112086 - Residual ratio : 0.00070777 - Slope : -1.13038 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2201 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.56241 - Final Residual ratio : 0.00193937 - Residual ratio : 0.000756854 - Slope : -0.16003 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2211 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.75184 - Final Residual ratio : 0.00148691 - Residual ratio : 0.000848768 - Slope : -0.125026 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2221 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.70644 - Final Residual ratio : 0.00159567 - Residual ratio : 0.00093509 - Slope : -0.121774 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2231 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.63539 - Final Residual ratio : 0.000653768 - Residual ratio : 0.000399762 - Slope : -0.116767 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2241 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.48431 - Final Residual ratio : 0.0010073 - Residual ratio : 0.000678635 - Slope : -0.10595 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2251 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.3656 - Final Residual ratio : 0.0007724 - Residual ratio : 0.000565613 - Slope : -0.0909884 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2261 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21661 - Final Residual ratio : 0.000661451 - Residual ratio : 0.000543685 - Slope : -0.0810629 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2271 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.06742 - Final Residual ratio : 0.0010452 - Residual ratio : 0.000979186 - Slope : -0.0761695 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2281 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.931671 - Final Residual ratio : 0.000635383 - Residual ratio : 0.000681982 - Slope : -0.0716181 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2291 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.783342 - Final Residual ratio : 0.000468061 - Residual ratio : 0.000597519 - Slope : -0.0460514 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2301 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.718305 - Final Residual ratio : 0.000510182 - Residual ratio : 0.000710258 - Slope : -0.0448622 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2311 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.65604 - Final Residual ratio : 0.000585663 - Residual ratio : 0.000892725 - Slope : -0.0436969 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2321 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.607047 - Final Residual ratio : 0.000297317 - Residual ratio : 0.000489775 - Slope : -0.04045 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2331 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.569409 - Final Residual ratio : 0.000277343 - Residual ratio : 0.000487071 - Slope : -0.0379421 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2341 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.532827 - Final Residual ratio : 0.000354805 - Residual ratio : 0.000665892 - Slope : -0.0354981 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2351 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.511151 - Final Residual ratio : 0.000320369 - Residual ratio : 0.00062676 - Slope : -0.0319269 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2361 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.499284 - Final Residual ratio : 0.000230427 - Residual ratio : 0.000461515 - Slope : -0.0277252 - Tolerance : 0.001 - Number of iterations : 18 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2371 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 64.7854 - Final Residual ratio : 0.0499552 - Residual ratio : 0.000771087 - Slope : -4.3157 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2381 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.5572 - Final Residual ratio : 0.0185788 - Residual ratio : 0.000699575 - Slope : -1.76924 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2391 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.79043 - Final Residual ratio : 0.00362961 - Residual ratio : 0.000757679 - Slope : -0.299175 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2401 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.36792 - Final Residual ratio : 0.00366813 - Residual ratio : 0.000839789 - Slope : -0.272766 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2411 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.68746 - Final Residual ratio : 0.00320229 - Residual ratio : 0.00068316 - Slope : -0.312284 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2421 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.57306 - Final Residual ratio : 0.0029239 - Residual ratio : 0.000639375 - Slope : -0.326438 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2431 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.19511 - Final Residual ratio : 0.00316686 - Residual ratio : 0.000754894 - Slope : -0.299425 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2441 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.4921 - Final Residual ratio : 0.0117304 - Residual ratio : 0.000478947 - Slope : -1.44002 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2451 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.0555 - Final Residual ratio : 0.0125436 - Residual ratio : 0.000694722 - Slope : -1.28878 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2461 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.7392 - Final Residual ratio : 0.0153012 - Residual ratio : 0.000972175 - Slope : -1.20953 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2471 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.89621 - Final Residual ratio : 0.00148419 - Residual ratio : 0.000512459 - Slope : -0.18092 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2481 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.06616 - Final Residual ratio : 0.00182825 - Residual ratio : 0.000884853 - Slope : -0.147452 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2491 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.8922 - Final Residual ratio : 0.0018295 - Residual ratio : 0.000966864 - Slope : -0.126025 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2501 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.7724 - Final Residual ratio : 0.00112524 - Residual ratio : 0.000634867 - Slope : -0.110705 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2511 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61144 - Final Residual ratio : 0.00152119 - Residual ratio : 0.000943991 - Slope : -0.114995 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2521 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.43059 - Final Residual ratio : 0.000690655 - Residual ratio : 0.000482777 - Slope : -0.0893686 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2531 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.2505 - Final Residual ratio : 0.00124549 - Residual ratio : 0.000996 - Slope : -0.0892322 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2541 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07911 - Final Residual ratio : 0.00107002 - Residual ratio : 0.000991574 - Slope : -0.0829261 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2551 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.971864 - Final Residual ratio : 0.000690717 - Residual ratio : 0.000710714 - Slope : -0.0647449 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2561 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.894039 - Final Residual ratio : 0.00066273 - Residual ratio : 0.000741276 - Slope : -0.0525516 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2571 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.831311 - Final Residual ratio : 0.000519275 - Residual ratio : 0.000624646 - Slope : -0.0488701 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2581 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.766551 - Final Residual ratio : 0.000502177 - Residual ratio : 0.000655113 - Slope : -0.0450617 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2591 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.676887 - Final Residual ratio : 0.000472736 - Residual ratio : 0.000698398 - Slope : -0.0397891 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2601 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 62.7993 - Final Residual ratio : 0.0505322 - Residual ratio : 0.000804661 - Slope : -4.18325 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2611 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.4041 - Final Residual ratio : 0.0188957 - Residual ratio : 0.000715637 - Slope : -1.75901 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2621 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.94537 - Final Residual ratio : 0.0027563 - Residual ratio : 0.000557351 - Slope : -0.308913 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2631 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.1969 - Final Residual ratio : 0.00409629 - Residual ratio : 0.000976029 - Slope : -0.26205 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2641 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.56774 - Final Residual ratio : 0.00315389 - Residual ratio : 0.00069047 - Slope : -0.285287 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2651 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.45367 - Final Residual ratio : 0.00419423 - Residual ratio : 0.000941747 - Slope : -0.31782 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2661 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.0836 - Final Residual ratio : 0.00403237 - Residual ratio : 0.000987453 - Slope : -0.291398 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2671 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 24.0767 - Final Residual ratio : 0.0109902 - Residual ratio : 0.000456465 - Slope : -1.41563 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2681 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 17.778 - Final Residual ratio : 0.0124927 - Residual ratio : 0.000702708 - Slope : -1.26896 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2691 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.6689 - Final Residual ratio : 0.0150198 - Residual ratio : 0.000958573 - Slope : -1.30449 - Tolerance : 0.001 - Number of iterations : 12 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2701 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.8241 - Final Residual ratio : 0.00130929 - Residual ratio : 0.000463611 - Slope : -0.176425 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2711 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.9635 - Final Residual ratio : 0.00117328 - Residual ratio : 0.000597544 - Slope : -0.150949 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2721 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.80206 - Final Residual ratio : 0.000912007 - Residual ratio : 0.000506093 - Slope : -0.128653 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2731 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.65399 - Final Residual ratio : 0.0007676 - Residual ratio : 0.000464089 - Slope : -0.110215 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2741 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.46458 - Final Residual ratio : 0.00105185 - Residual ratio : 0.000718195 - Slope : -0.0975683 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2751 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.34103 - Final Residual ratio : 0.000942279 - Residual ratio : 0.000702652 - Slope : -0.0893393 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2761 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.21824 - Final Residual ratio : 0.000783035 - Residual ratio : 0.000642758 - Slope : -0.0760912 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2771 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.11536 - Final Residual ratio : 0.000881592 - Residual ratio : 0.000790413 - Slope : -0.0696546 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2781 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.02771 - Final Residual ratio : 0.000658264 - Residual ratio : 0.000640517 - Slope : -0.0641906 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2791 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.918545 - Final Residual ratio : 0.000841897 - Residual ratio : 0.000916555 - Slope : -0.0573564 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2801 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.837072 - Final Residual ratio : 0.000533751 - Residual ratio : 0.00063764 - Slope : -0.0522837 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2811 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.73276 - Final Residual ratio : 0.000636358 - Residual ratio : 0.000868441 - Slope : -0.0430661 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2821 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.624558 - Final Residual ratio : 0.000496435 - Residual ratio : 0.000794858 - Slope : -0.0390039 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2831 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.53987 - Final Residual ratio : 0.000460191 - Residual ratio : 0.000852411 - Slope : -0.0337131 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2841 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 62.59 - Final Residual ratio : 0.0476131 - Residual ratio : 0.000760716 - Slope : -4.16949 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2851 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 26.2713 - Final Residual ratio : 0.0175958 - Residual ratio : 0.000669772 - Slope : -1.75025 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2861 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.9488 - Final Residual ratio : 0.00487882 - Residual ratio : 0.000985859 - Slope : -0.449448 - Tolerance : 0.001 - Number of iterations : 11 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2871 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.18999 - Final Residual ratio : 0.00380403 - Residual ratio : 0.000907886 - Slope : -0.261636 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2881 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.57807 - Final Residual ratio : 0.00398439 - Residual ratio : 0.000870321 - Slope : -0.304939 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2891 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 4.49692 - Final Residual ratio : 0.00333572 - Residual ratio : 0.000741779 - Slope : -0.32097 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2901 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 25.5474 - Final Residual ratio : 0.01205 - Residual ratio : 0.000471671 - Slope : -1.50208 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2911 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 18.4376 - Final Residual ratio : 0.0114452 - Residual ratio : 0.000620752 - Slope : -1.31616 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2921 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 15.7827 - Final Residual ratio : 0.0151307 - Residual ratio : 0.000958694 - Slope : -1.21289 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2931 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 2.44679 - Final Residual ratio : 0.00172069 - Residual ratio : 0.000703243 - Slope : -0.152817 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2941 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.66455 - Final Residual ratio : 0.00137652 - Residual ratio : 0.000826964 - Slope : -0.127936 - Tolerance : 0.001 - Number of iterations : 13 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2951 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.64736 - Final Residual ratio : 0.00105915 - Residual ratio : 0.000642937 - Slope : -0.117593 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2961 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.61008 - Final Residual ratio : 0.000967849 - Residual ratio : 0.000601117 - Slope : -0.10057 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2971 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.52107 - Final Residual ratio : 0.00103716 - Residual ratio : 0.00068186 - Slope : -0.0950023 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2981 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.39215 - Final Residual ratio : 0.00121704 - Residual ratio : 0.000874215 - Slope : -0.0869331 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.2991 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.20597 - Final Residual ratio : 0.000653927 - Residual ratio : 0.000542242 - Slope : -0.0753322 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.3001 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 1.07839 - Final Residual ratio : 0.00088382 - Residual ratio : 0.00081957 - Slope : -0.076965 - Tolerance : 0.001 - Number of iterations : 14 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.3011 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.946695 - Final Residual ratio : 0.000585704 - Residual ratio : 0.000618683 - Slope : -0.063074 - Tolerance : 0.001 - Number of iterations : 15 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.3021 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.836325 - Final Residual ratio : 0.000578743 - Residual ratio : 0.000692007 - Slope : -0.0522341 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.3031 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.749994 - Final Residual ratio : 0.000566293 - Residual ratio : 0.000755063 - Slope : -0.044084 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.3041 -dimension in distance computation 2 -elements_to_solve.size() : 54 -redistance was executed -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.670844 - Final Residual ratio : 0.000498667 - Residual ratio : 0.000743343 - Slope : -0.0394321 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.3051 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.611637 - Final Residual ratio : 0.000387273 - Residual ratio : 0.000633175 - Slope : -0.0359559 - Tolerance : 0.001 - Number of iterations : 17 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.3061 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.5535 - Final Residual ratio : 0.00043565 - Residual ratio : 0.000787082 - Slope : -0.0291087 - Tolerance : 0.001 - Number of iterations : 19 - Maximum number of iterations : 5000 -0.001 -0.001 -******** CURRENT TIME = 2.3071 -*pLinearSolver : Biconjugate gradient stabilized linear solver with Diagonal preconditioner - Initial Residual ratio : 0.502248 - Final Residual ratio : 0.00042677 - Residual ratio : 0.00084972 - Slope : -0.0313638 - Tolerance : 0.001 - Number of iterations : 16 - Maximum number of iterations : 5000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.init b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.init deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.lin b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.lin deleted file mode 100644 index 767093c4f13e..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.lin and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.mdpa b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.mdpa deleted file mode 100644 index 97b099af94d7..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.mdpa +++ /dev/null @@ -1,2286 +0,0 @@ -Begin ModelPartData -// VARIABLE_NAME value -End ModelPartData - -Begin Properties 0 -End Properties - - -Begin Nodes -1 2.50000 2.00000 0.00000 -2 2.40000 2.00000 0.00000 -3 2.50000 1.90000 0.00000 -4 2.34267 1.89992 0.00000 -5 2.30000 2.00000 0.00000 -6 2.50000 1.80000 0.00000 -7 2.39685 1.81518 0.00000 -8 2.41971 1.73986 0.00000 -9 2.24294 1.90573 0.00000 -10 2.28748 1.81665 0.00000 -11 2.20000 2.00000 0.00000 -12 2.50000 1.70000 0.00000 -13 2.33127 1.73465 0.00000 -14 2.18816 1.82404 0.00000 -15 2.39941 1.64940 0.00000 -16 2.14458 1.90649 0.00000 -17 2.23140 1.73398 0.00000 -18 2.50000 1.60000 0.00000 -19 2.10000 2.00000 0.00000 -20 2.28153 1.64804 0.00000 -21 2.08826 1.82508 0.00000 -22 2.13702 1.73821 0.00000 -23 2.41744 1.55944 0.00000 -24 2.04569 1.91103 0.00000 -25 2.33167 1.56153 0.00000 -26 2.18205 1.64936 0.00000 -27 2.50000 1.50000 0.00000 -28 2.00000 2.00000 0.00000 -29 2.22605 1.55699 0.00000 -30 2.03858 1.73874 0.00000 -31 2.35611 1.48629 0.00000 -32 1.99378 1.82595 0.00000 -33 2.08267 1.65613 0.00000 -34 1.94604 1.91229 0.00000 -35 2.12792 1.56753 0.00000 -36 2.26258 1.46425 0.00000 -37 2.16706 1.50164 0.00000 -38 2.50000 1.40000 0.00000 -39 1.90000 2.00000 0.00000 -40 2.40830 1.40106 0.00000 -41 1.93880 1.74283 0.00000 -42 1.98475 1.65462 0.00000 -43 1.89534 1.83252 0.00000 -44 2.02867 1.57443 0.00000 -45 2.28247 1.38541 0.00000 -46 2.08396 1.49471 0.00000 -47 1.84725 1.91958 0.00000 -48 2.15697 1.41771 0.00000 -49 1.84829 1.75128 0.00000 -50 2.50000 1.30000 0.00000 -51 1.80000 2.00000 0.00000 -52 2.35998 1.31381 0.00000 -53 1.88549 1.66083 0.00000 -54 1.92972 1.57129 0.00000 -55 1.79596 1.83629 0.00000 -56 1.97886 1.48887 0.00000 -57 2.04429 1.41811 0.00000 -58 2.27157 1.29225 0.00000 -59 2.18243 1.31545 0.00000 -60 1.74956 1.91452 0.00000 -61 2.41398 1.23017 0.00000 -62 1.83791 1.59121 0.00000 -63 1.78679 1.67312 0.00000 -64 2.08477 1.32678 0.00000 -65 1.88387 1.50247 0.00000 -66 1.74849 1.74908 0.00000 -67 2.31594 1.22453 0.00000 -68 2.50000 1.20000 0.00000 -69 1.70000 2.00000 0.00000 -70 1.92923 1.41343 0.00000 -71 1.69680 1.83128 0.00000 -72 2.21702 1.22207 0.00000 -73 1.98499 1.33187 0.00000 -74 2.11911 1.24024 0.00000 -75 1.65083 1.91853 0.00000 -76 2.38987 1.14476 0.00000 -77 1.78422 1.50692 0.00000 -78 1.69154 1.66457 0.00000 -79 1.72854 1.57198 0.00000 -80 1.65163 1.75595 0.00000 -81 1.82944 1.41888 0.00000 -82 2.03019 1.24311 0.00000 -83 2.26538 1.13947 0.00000 -84 2.50000 1.10000 0.00000 -85 1.60000 2.00000 0.00000 -86 2.17091 1.15486 0.00000 -87 1.88162 1.33382 0.00000 -88 1.59856 1.83997 0.00000 -89 1.93188 1.24761 0.00000 -90 2.41675 1.06069 0.00000 -91 1.55549 1.92999 0.00000 -92 2.07148 1.15246 0.00000 -93 1.68445 1.50341 0.00000 -94 1.73686 1.41904 0.00000 -95 2.31702 1.05844 0.00000 -96 1.63000 1.58723 0.00000 -97 1.59327 1.67510 0.00000 -98 2.22149 1.06875 0.00000 -99 1.78250 1.33083 0.00000 -100 1.97248 1.16339 0.00000 -101 1.54040 1.75965 0.00000 -102 2.50000 1.00000 0.00000 -103 1.50000 2.00000 0.00000 -104 2.12162 1.06847 0.00000 -105 1.83209 1.24791 0.00000 -106 1.49966 1.84728 0.00000 -107 2.36879 0.97869 0.00000 -108 1.55078 1.58987 0.00000 -109 2.02401 1.07487 0.00000 -110 1.63970 1.41474 0.00000 -111 1.58476 1.49810 0.00000 -112 1.87359 1.15715 0.00000 -113 2.25996 0.97749 0.00000 -114 1.68342 1.33779 0.00000 -115 1.44798 1.93265 0.00000 -116 1.49452 1.67112 0.00000 -117 1.73609 1.25881 0.00000 -118 1.45463 1.76177 0.00000 -119 2.16783 0.98022 0.00000 -120 1.92558 1.07611 0.00000 -121 2.50000 0.90000 0.00000 -122 1.40000 2.00000 0.00000 -123 2.06836 0.98567 0.00000 -124 1.77431 1.16731 0.00000 -125 1.40052 1.84487 0.00000 -126 1.49438 1.50989 0.00000 -127 2.40814 0.88354 0.00000 -128 1.53993 1.42100 0.00000 -129 1.45180 1.59978 0.00000 -130 2.31086 0.89196 0.00000 -131 1.58431 1.33152 0.00000 -132 1.82973 1.08530 0.00000 -133 1.96903 0.99321 0.00000 -134 1.63714 1.24992 0.00000 -135 1.35840 1.93478 0.00000 -136 2.21133 0.89229 0.00000 -137 1.39886 1.67994 0.00000 -138 1.69226 1.16965 0.00000 -139 1.35519 1.76963 0.00000 -140 2.11335 0.89647 0.00000 -141 1.86939 0.99450 0.00000 -142 1.73082 1.08191 0.00000 -143 2.50000 0.80000 0.00000 -144 1.30000 2.00000 0.00000 -145 2.01214 0.90309 0.00000 -146 1.44054 1.42577 0.00000 -147 1.30367 1.85194 0.00000 -148 2.35203 0.80147 0.00000 -149 1.48466 1.33826 0.00000 -150 1.54006 1.25508 0.00000 -151 1.38642 1.50982 0.00000 -152 1.79576 1.00646 0.00000 -153 2.26081 0.80553 0.00000 -154 1.59490 1.17154 0.00000 -155 1.34042 1.59694 0.00000 -156 1.30978 1.68073 0.00000 -157 1.91706 0.90819 0.00000 -158 2.15865 0.80786 0.00000 -159 1.25205 1.93754 0.00000 -160 1.25602 1.76484 0.00000 -161 2.05889 0.81275 0.00000 -162 1.63916 1.06835 0.00000 -163 1.81869 0.91500 0.00000 -164 2.40204 0.71548 0.00000 -165 1.39447 1.33718 0.00000 -166 1.71396 0.97473 0.00000 -167 1.34080 1.42087 0.00000 -168 2.30258 0.71698 0.00000 -169 1.96160 0.81875 0.00000 -170 1.44053 1.24859 0.00000 -171 2.50000 0.70000 0.00000 -172 1.20000 2.00000 0.00000 -173 1.29340 1.50879 0.00000 -174 1.20387 1.84996 0.00000 -175 1.49512 1.16604 0.00000 -176 2.20337 0.72431 0.00000 -177 1.24058 1.59324 0.00000 -178 1.53956 1.07669 0.00000 -179 2.10465 0.72522 0.00000 -180 1.86190 0.82519 0.00000 -181 1.19220 1.68066 0.00000 -182 1.15208 1.93549 0.00000 -183 1.76319 0.86719 0.00000 -184 2.00503 0.72886 0.00000 -185 1.15610 1.76216 0.00000 -186 1.58198 0.98637 0.00000 -187 1.34123 1.25271 0.00000 -188 2.35516 0.62636 0.00000 -189 1.28737 1.33688 0.00000 -190 1.24129 1.42357 0.00000 -191 2.24659 0.63428 0.00000 -192 1.38551 1.16582 0.00000 -193 1.64702 0.89537 0.00000 -194 1.90598 0.73368 0.00000 -195 2.50000 0.60000 0.00000 -196 1.10000 2.00000 0.00000 -197 1.18834 1.50835 0.00000 -198 1.44057 1.08248 0.00000 -199 1.10391 1.84745 0.00000 -200 2.15321 0.63816 0.00000 -201 1.14092 1.59490 0.00000 -202 1.48261 0.99552 0.00000 -203 2.05330 0.63950 0.00000 -204 1.06931 1.93210 0.00000 -205 1.79097 0.74711 0.00000 -206 1.08865 1.68011 0.00000 -207 1.68890 0.80036 0.00000 -208 1.53930 0.91330 0.00000 -209 2.19452 0.57015 0.00000 -210 2.39529 0.54033 0.00000 -211 2.28443 0.55110 0.00000 -212 1.19388 1.33575 0.00000 -213 1.24163 1.24803 0.00000 -214 1.29459 1.16457 0.00000 -215 1.95327 0.63753 0.00000 -216 1.14155 1.42003 0.00000 -217 1.04025 1.76655 0.00000 -218 1.59479 0.83028 0.00000 -219 1.34120 1.07630 0.00000 -220 1.09295 1.50732 0.00000 -221 1.39488 0.99402 0.00000 -222 1.85415 0.64841 0.00000 -223 2.09690 0.55601 0.00000 -224 2.50000 0.50000 0.00000 -225 1.00000 2.00000 0.00000 -226 1.77539 0.67223 0.00000 -227 0.99056 1.87756 0.00000 -228 1.04110 1.59217 0.00000 -229 1.44018 0.90512 0.00000 -230 2.01049 0.55148 0.00000 -231 0.99188 1.67914 0.00000 -232 1.61305 0.73712 0.00000 -233 1.49511 0.82420 0.00000 -234 1.68730 0.68273 0.00000 -235 2.33917 0.45767 0.00000 -236 2.43888 0.45036 0.00000 -237 1.14217 1.25031 0.00000 -238 1.18840 1.16399 0.00000 -239 2.18003 0.47456 0.00000 -240 1.24196 1.07975 0.00000 -241 1.08943 1.33512 0.00000 -242 1.04193 1.42142 0.00000 -243 1.28654 0.99339 0.00000 -244 2.08019 0.47966 0.00000 -245 0.94037 1.76441 0.00000 -246 0.98980 1.50664 0.00000 -247 1.53860 0.73448 0.00000 -248 1.34120 0.90992 0.00000 -249 1.90282 0.51707 0.00000 -250 2.50000 0.40000 0.00000 -251 0.90000 2.00000 0.00000 -252 1.73362 0.58669 0.00000 -253 0.94137 1.59291 0.00000 -254 0.89070 1.85115 0.00000 -255 1.98907 0.46664 0.00000 -256 1.38390 0.82356 0.00000 -257 2.41263 0.37661 0.00000 -258 1.09699 1.16344 0.00000 -259 1.57925 0.64343 0.00000 -260 1.04274 1.24683 0.00000 -261 2.23616 0.37986 0.00000 -262 0.88967 1.67843 0.00000 -263 1.14276 1.07520 0.00000 -264 0.99557 1.33451 0.00000 -265 1.43998 0.74112 0.00000 -266 1.19833 0.99290 0.00000 -267 2.32490 0.35851 0.00000 -268 2.12579 0.39070 0.00000 -269 0.94234 1.41873 0.00000 -270 1.24228 0.90397 0.00000 -271 1.63693 0.56990 0.00000 -272 1.77858 0.48929 0.00000 -273 0.84056 1.76468 0.00000 -274 2.02589 0.39220 0.00000 -275 0.82389 1.92764 0.00000 -276 0.89414 1.50598 0.00000 -277 1.29951 0.82307 0.00000 -278 1.48018 0.65475 0.00000 -279 2.50000 0.30000 0.00000 -280 0.80000 2.00000 0.00000 -281 1.92598 0.39278 0.00000 -282 0.84166 1.59079 0.00000 -283 2.37458 0.29160 0.00000 -284 1.34145 0.73334 0.00000 -285 2.27303 0.29797 0.00000 -286 0.78917 1.85041 0.00000 -287 0.99717 1.16608 0.00000 -288 1.53811 0.57358 0.00000 -289 1.04524 1.07857 0.00000 -290 1.09861 0.99688 0.00000 -291 1.68046 0.48018 0.00000 -292 0.94454 1.24902 0.00000 -293 1.83233 0.40540 0.00000 -294 2.17406 0.29975 0.00000 -295 0.89570 1.33616 0.00000 -296 0.79270 1.67773 0.00000 -297 1.40078 0.65429 0.00000 -298 1.14564 0.90885 0.00000 -299 2.07429 0.30509 0.00000 -300 1.19991 0.82874 0.00000 -301 0.84362 1.42004 0.00000 -302 0.73957 1.93665 0.00000 -303 1.58107 0.48830 0.00000 -304 1.73275 0.40206 0.00000 -305 1.97571 0.30612 0.00000 -306 0.74076 1.76297 0.00000 -307 0.79422 1.50690 0.00000 -308 1.24553 0.74002 0.00000 -309 1.43973 0.56360 0.00000 -310 2.41833 0.20730 0.00000 -311 1.30002 0.66080 0.00000 -312 1.87600 0.31220 0.00000 -313 2.31856 0.20922 0.00000 -314 2.50000 0.20000 0.00000 -315 0.70000 2.00000 0.00000 -316 0.74255 1.59147 0.00000 -317 2.21898 0.21503 0.00000 -318 0.89773 1.16115 0.00000 -319 0.99942 0.99036 0.00000 -320 0.94548 1.07438 0.00000 -321 1.50069 0.48573 0.00000 -322 0.69127 1.84968 0.00000 -323 1.63382 0.40437 0.00000 -324 0.84470 1.24580 0.00000 -325 1.04598 0.90344 0.00000 -326 2.11929 0.21619 0.00000 -327 1.10107 0.82022 0.00000 -328 0.79608 1.33242 0.00000 -329 1.77771 0.31302 0.00000 -330 0.69276 1.67813 0.00000 -331 1.34547 0.57255 0.00000 -332 2.01987 0.22289 0.00000 -333 0.74373 1.41753 0.00000 -334 1.14594 0.73424 0.00000 -335 1.40231 0.49683 0.00000 -336 0.63971 1.93521 0.00000 -337 1.53748 0.39927 0.00000 -338 1.92027 0.22301 0.00000 -339 1.67818 0.31951 0.00000 -340 1.20142 0.65133 0.00000 -341 0.69448 1.50404 0.00000 -342 0.64138 1.76319 0.00000 -343 2.36616 0.12224 0.00000 -344 2.26715 0.12748 0.00000 -345 0.89959 0.99429 0.00000 -346 0.84573 1.07602 0.00000 -347 1.82100 0.23074 0.00000 -348 0.79782 1.16373 0.00000 -349 2.16725 0.12981 0.00000 -350 2.50000 0.10000 0.00000 -351 0.60000 2.00000 0.00000 -352 0.94636 0.90601 0.00000 -353 0.64263 1.58948 0.00000 -354 1.24866 0.56715 0.00000 -355 1.00143 0.82612 0.00000 -356 0.74487 1.24673 0.00000 -357 1.57895 0.32502 0.00000 -358 1.43910 0.40822 0.00000 -359 0.59132 1.84774 0.00000 -360 0.69879 1.33522 0.00000 -361 1.30331 0.49589 0.00000 -362 1.04673 0.73717 0.00000 -363 1.72152 0.22956 0.00000 -364 0.59294 1.67589 0.00000 -365 2.05997 0.11427 0.00000 -366 0.64385 1.41794 0.00000 -367 1.09378 0.64914 0.00000 -368 0.54602 1.92235 0.00000 -369 1.35662 0.41246 0.00000 -370 1.96012 0.11674 0.00000 -371 0.59994 1.50759 0.00000 -372 0.54981 1.75758 0.00000 -373 1.47708 0.32110 0.00000 -374 1.62199 0.23754 0.00000 -375 0.80035 0.98750 0.00000 -376 0.74598 1.07127 0.00000 -377 0.84675 0.89964 0.00000 -378 1.86018 0.11886 0.00000 -379 0.90260 0.81691 0.00000 -380 0.69710 1.15808 0.00000 -381 1.20445 0.48700 0.00000 -382 0.96005 0.73528 0.00000 -383 0.65248 1.24678 0.00000 -384 0.54350 1.58950 0.00000 -385 2.50000 0.00000 0.00000 -386 0.50000 2.00000 0.00000 -387 1.13728 0.53534 0.00000 -388 2.39925 0.00000 0.00000 -389 1.00331 0.66646 0.00000 -390 1.39881 0.32215 0.00000 -391 1.25874 0.42077 0.00000 -392 1.53248 0.23932 0.00000 -393 2.29850 0.00000 0.00000 -394 0.49465 1.84010 0.00000 -395 0.59955 1.33142 0.00000 -396 1.76080 0.12197 0.00000 -397 2.19776 0.00000 0.00000 -398 1.67305 0.15198 0.00000 -399 0.55559 1.41811 0.00000 -400 0.49479 1.67631 0.00000 -401 2.09701 0.00000 0.00000 -402 0.44851 1.91702 0.00000 -403 1.30040 0.33014 0.00000 -404 0.50066 1.50151 0.00000 -405 1.99626 0.00000 0.00000 -406 0.70107 0.98905 0.00000 -407 0.45138 1.75062 0.00000 -408 1.43788 0.23044 0.00000 -409 0.80575 0.82081 0.00000 -410 0.86039 0.74076 0.00000 -411 0.74697 0.90313 0.00000 -412 1.57452 0.14994 0.00000 -413 0.59912 1.16836 0.00000 -414 1.14927 0.42367 0.00000 -415 0.91780 0.65014 0.00000 -416 0.99821 0.56057 0.00000 -417 0.45239 1.58664 0.00000 -418 1.89551 0.00000 0.00000 -419 0.62125 1.07329 0.00000 -420 0.40000 2.00000 0.00000 -421 1.47655 0.16252 0.00000 -422 1.33906 0.24354 0.00000 -423 0.50033 1.33560 0.00000 -424 1.20180 0.33888 0.00000 -425 0.39731 1.83401 0.00000 -426 0.52407 1.23853 0.00000 -427 1.79477 0.00000 0.00000 -428 1.62113 0.06821 0.00000 -429 0.39830 1.66978 0.00000 -430 0.45283 1.41179 0.00000 -431 1.05073 0.43402 0.00000 -432 1.52996 0.09145 0.00000 -433 0.65775 0.90179 0.00000 -434 0.70611 0.81496 0.00000 -435 0.76154 0.73196 0.00000 -436 0.34920 1.92098 0.00000 -437 0.60184 0.98393 0.00000 -438 1.24066 0.25122 0.00000 -439 0.81864 0.65010 0.00000 -440 1.69402 0.00000 0.00000 -441 0.40119 1.50136 0.00000 -442 0.35245 1.75773 0.00000 -443 1.37834 0.15193 0.00000 -444 1.10287 0.33537 0.00000 -445 0.86427 0.56448 0.00000 -446 0.50070 1.12514 0.00000 -447 0.35275 1.58099 0.00000 -448 1.59327 0.00000 0.00000 -449 0.30000 2.00000 0.00000 -450 0.30566 1.83142 0.00000 -451 1.43270 0.07401 0.00000 -452 1.15836 0.25339 0.00000 -453 1.27950 0.16483 0.00000 -454 0.40568 1.30085 0.00000 -455 0.93006 0.43934 0.00000 -456 0.50486 1.02757 0.00000 -457 0.35355 1.41334 0.00000 -458 0.29858 1.67372 0.00000 -459 0.66450 0.73551 0.00000 -460 0.60858 0.81542 0.00000 -461 0.71895 0.65511 0.00000 -462 1.49252 0.00000 0.00000 -463 1.33831 0.08484 0.00000 -464 0.41254 1.17192 0.00000 -465 0.53251 0.91465 0.00000 -466 1.20280 0.16439 0.00000 -467 0.76502 0.56656 0.00000 -468 0.25108 1.91472 0.00000 -469 0.30116 1.49613 0.00000 -470 0.25594 1.74816 0.00000 -471 1.05890 0.24583 0.00000 -472 0.41575 1.07276 0.00000 -473 0.96901 0.30776 0.00000 -474 0.25557 1.58436 0.00000 -475 1.39177 0.00000 0.00000 -476 0.81651 0.44764 0.00000 -477 0.30170 1.32843 0.00000 -478 0.20645 1.83419 0.00000 -479 0.20000 2.00000 0.00000 -480 1.24192 0.07293 0.00000 -481 1.10504 0.16941 0.00000 -482 0.51098 0.82702 0.00000 -483 0.32341 1.21682 0.00000 -484 0.62002 0.64675 0.00000 -485 0.42101 0.97324 0.00000 -486 0.25564 1.41662 0.00000 -487 0.67678 0.56463 0.00000 -488 0.20212 1.66789 0.00000 -489 0.17243 1.92348 0.00000 -490 1.29103 0.00000 0.00000 -491 0.86568 0.32910 0.00000 -492 0.53698 0.73101 0.00000 -493 0.32977 1.11722 0.00000 -494 1.14339 0.08660 0.00000 -495 0.20142 1.50049 0.00000 -496 0.15710 1.75626 0.00000 -497 1.00578 0.17321 0.00000 -498 0.42257 0.87359 0.00000 -499 0.70469 0.45632 0.00000 -500 0.33284 1.01746 0.00000 -501 0.23710 1.25287 0.00000 -502 1.19110 0.00000 0.00000 -503 0.20190 1.33244 0.00000 -504 0.14143 1.58773 0.00000 -505 0.10460 1.86848 0.00000 -506 0.10000 2.00000 0.00000 -507 1.05018 0.08660 0.00000 -508 0.57359 0.56427 0.00000 -509 0.76431 0.33458 0.00000 -510 0.90376 0.19909 0.00000 -511 0.42630 0.77396 0.00000 -512 0.23316 1.16319 0.00000 -513 0.33607 0.92309 0.00000 -514 0.50193 0.62637 0.00000 -515 0.13974 1.41155 0.00000 -516 0.08585 1.68203 0.00000 -517 0.81040 0.24623 0.00000 -518 0.24527 1.06412 0.00000 -519 1.09567 0.00000 0.00000 -520 0.42654 0.69205 0.00000 -521 0.95990 0.09073 0.00000 -522 0.58668 0.45528 0.00000 -523 0.33864 0.82146 0.00000 -524 0.08312 1.49687 0.00000 -525 0.24724 0.96727 0.00000 -526 0.65558 0.34067 0.00000 -527 0.82833 0.15548 0.00000 -528 0.09635 1.33051 0.00000 -529 0.48256 0.52833 0.00000 -530 1.00469 0.00000 0.00000 -531 0.12395 1.22458 0.00000 -532 0.00000 2.00000 0.00000 -533 0.00000 1.89873 0.00000 -534 0.71188 0.24985 0.00000 -535 0.00000 1.79746 0.00000 -536 0.87692 0.08549 0.00000 -537 0.15382 1.10263 0.00000 -538 0.25190 0.87058 0.00000 -539 0.00000 1.69619 0.00000 -540 0.34317 0.69807 0.00000 -541 0.40741 0.59391 0.00000 -542 0.00000 1.59492 0.00000 -543 0.75385 0.16547 0.00000 -544 0.16888 1.00455 0.00000 -545 0.91808 0.00000 0.00000 -546 0.00000 1.49365 0.00000 -547 0.25217 0.77186 0.00000 -548 0.79671 0.08113 0.00000 -549 0.17273 0.90547 0.00000 -550 0.00000 1.39237 0.00000 -551 0.46864 0.42067 0.00000 -552 0.61439 0.23517 0.00000 -553 0.06171 1.13570 0.00000 -554 0.67967 0.16129 0.00000 -555 0.53734 0.31269 0.00000 -556 0.38791 0.49688 0.00000 -557 0.08660 1.04105 0.00000 -558 0.00000 1.29110 0.00000 -559 0.83576 0.00000 0.00000 -560 0.16890 0.81713 0.00000 -561 0.31485 0.55887 0.00000 -562 0.72063 0.07688 0.00000 -563 0.00000 1.18983 0.00000 -564 0.08660 0.94921 0.00000 -565 0.23804 0.65355 0.00000 -566 0.44602 0.33226 0.00000 -567 0.75765 0.00000 0.00000 -568 0.16279 0.74032 0.00000 -569 0.00000 1.08856 0.00000 -570 0.37131 0.39861 0.00000 -571 0.08567 0.86363 0.00000 -572 0.64858 0.07277 0.00000 -573 0.29492 0.46102 0.00000 -574 0.54308 0.15331 0.00000 -575 0.00000 0.99354 0.00000 -576 0.68362 0.00000 0.00000 -577 0.45059 0.23879 0.00000 -578 0.07945 0.78413 0.00000 -579 0.22029 0.52675 0.00000 -580 0.00000 0.90487 0.00000 -581 0.36256 0.29535 0.00000 -582 0.57372 0.05820 0.00000 -583 0.13498 0.62542 0.00000 -584 0.07348 0.71050 0.00000 -585 0.61355 0.00000 0.00000 -586 0.27748 0.36817 0.00000 -587 0.00000 0.82238 0.00000 -588 0.51605 0.06494 0.00000 -589 0.20008 0.43108 0.00000 -590 0.43272 0.13146 0.00000 -591 0.36302 0.19874 0.00000 -592 0.54732 0.00000 0.00000 -593 0.00000 0.74588 0.00000 -594 0.05417 0.64014 0.00000 -595 0.11905 0.50877 0.00000 -596 0.06239 0.57981 0.00000 -597 0.45148 0.05082 0.00000 -598 0.00000 0.67512 0.00000 -599 0.48478 0.00000 0.00000 -600 0.26693 0.23553 0.00000 -601 0.18398 0.33342 0.00000 -602 0.05730 0.52218 0.00000 -603 0.00000 0.60984 0.00000 -604 0.39803 0.05770 0.00000 -605 0.32748 0.11830 0.00000 -606 0.10537 0.40810 0.00000 -607 0.42581 0.00000 0.00000 -608 0.05251 0.46931 0.00000 -609 0.00000 0.54977 0.00000 -610 0.34141 0.04541 0.00000 -611 0.04804 0.42090 0.00000 -612 0.00000 0.49460 0.00000 -613 0.37025 0.00000 0.00000 -614 0.09002 0.31654 0.00000 -615 0.29336 0.05107 0.00000 -616 0.04388 0.37664 0.00000 -617 0.00000 0.44403 0.00000 -618 0.14641 0.21797 0.00000 -619 0.31795 0.00000 0.00000 -620 0.21905 0.11113 0.00000 -621 0.00000 0.39777 0.00000 -622 0.03407 0.33303 0.00000 -623 0.07946 0.24915 0.00000 -624 0.24093 0.04145 0.00000 -625 0.00000 0.35552 0.00000 -626 0.03644 0.29945 0.00000 -627 0.26878 0.00000 0.00000 -628 0.00000 0.31699 0.00000 -629 0.03314 0.26595 0.00000 -630 0.20090 0.04504 0.00000 -631 0.14139 0.10240 0.00000 -632 0.22258 0.00000 0.00000 -633 0.00000 0.28191 0.00000 -634 0.02901 0.23740 0.00000 -635 0.07623 0.16763 0.00000 -636 0.00000 0.25000 0.00000 -637 0.03245 0.20313 0.00000 -638 0.15470 0.03647 0.00000 -639 0.17922 0.00000 0.00000 -640 0.00000 0.21875 0.00000 -641 0.02834 0.17105 0.00000 -642 -0.03333 0.25000 0.00000 -643 0.07913 0.09375 0.00000 -644 -0.02279 0.22593 0.00000 -645 0.11334 0.04483 0.00000 -646 0.00000 0.18750 0.00000 -647 0.03245 0.14063 0.00000 -648 0.13854 0.00000 0.00000 -649 -0.02722 0.19819 0.00000 -650 0.00000 0.15625 0.00000 -651 -0.06667 0.25000 0.00000 -652 0.02881 0.10625 0.00000 -653 -0.05753 0.21616 0.00000 -654 0.07189 0.04105 0.00000 -655 -0.02735 0.16840 0.00000 -656 0.10041 0.00000 0.00000 -657 0.00000 0.12500 0.00000 -658 0.03553 0.07213 0.00000 -659 -0.05271 0.18278 0.00000 -660 -0.10000 0.25000 0.00000 -661 -0.02393 0.13867 0.00000 -662 0.00000 0.09375 0.00000 -663 -0.04942 0.15381 0.00000 -664 0.06470 0.00000 0.00000 -665 -0.10000 0.21875 0.00000 -666 0.03339 0.03549 0.00000 -667 -0.02472 0.10885 0.00000 -668 0.00000 0.06250 0.00000 -669 -0.07549 0.16385 0.00000 -670 -0.04986 0.12392 0.00000 -671 -0.02165 0.08005 0.00000 -672 -0.10000 0.18750 0.00000 -673 0.03127 0.00000 0.00000 -674 -0.07534 0.13891 0.00000 -675 -0.04784 0.09468 0.00000 -676 0.00000 0.03125 0.00000 -677 -0.02321 0.05463 0.00000 -678 -0.10000 0.15625 0.00000 -679 -0.07402 0.10937 0.00000 -680 -0.04742 0.06468 0.00000 -681 0.00000 0.00000 0.00000 -682 -0.10000 0.12500 0.00000 -683 -0.07362 0.07930 0.00000 -684 -0.04063 0.03331 0.00000 -685 -0.10000 0.09375 0.00000 -686 -0.03333 0.00000 0.00000 -687 -0.07139 0.04517 0.00000 -688 -0.10000 0.06250 0.00000 -689 -0.06667 0.00000 0.00000 -690 -0.10000 0.03125 0.00000 -691 -0.10000 0.00000 0.00000 -End Nodes - -Begin Elements Fluid2D -1 0 682 685 679 -2 0 679 685 683 -3 0 679 683 675 -4 0 675 683 680 -5 0 675 680 671 -6 0 671 680 677 -7 0 671 677 668 -8 0 668 677 676 -9 0 671 668 662 -10 0 671 662 667 -11 0 676 684 686 -12 0 667 662 657 -13 0 671 667 675 -14 0 675 667 670 -15 0 670 667 661 -16 0 675 670 679 -17 0 679 670 674 -18 0 667 657 661 -19 0 661 657 650 -20 0 674 670 663 -21 0 679 674 682 -22 0 682 674 678 -23 0 661 650 655 -24 0 670 661 663 -25 0 663 661 655 -26 0 663 655 659 -27 0 659 655 649 -28 0 663 659 669 -29 0 663 669 674 -30 0 674 669 678 -31 0 678 669 672 -32 0 659 649 653 -33 0 669 659 672 -34 0 649 655 646 -35 0 649 646 640 -36 0 655 650 646 -37 0 653 649 644 -38 0 644 649 640 -39 0 644 640 636 -40 0 653 642 651 -41 0 659 653 672 -42 0 672 653 665 -43 0 677 680 684 -44 0 684 680 687 -45 0 687 680 683 -46 0 687 683 688 -47 0 687 688 690 -48 0 684 687 689 -49 0 677 684 676 -50 0 683 685 688 -51 0 681 676 686 -52 0 660 665 651 -53 0 690 691 689 -54 0 687 690 689 -55 0 689 686 684 -56 0 636 642 644 -57 0 644 642 653 -58 0 653 651 665 -59 0 657 662 652 -60 0 636 640 634 -61 0 681 673 676 -62 0 668 676 666 -63 0 646 650 641 -64 0 640 646 637 -65 0 650 657 647 -66 0 662 668 658 -67 0 633 636 629 -68 0 673 664 666 -69 0 628 633 626 -70 0 664 656 654 -71 0 666 676 673 -72 0 652 662 658 -73 0 652 658 643 -74 0 637 646 641 -75 0 637 641 635 -76 0 658 668 666 -77 0 658 666 654 -78 0 634 640 637 -79 0 634 637 623 -80 0 641 650 647 -81 0 641 647 635 -82 0 647 657 652 -83 0 647 652 643 -84 0 636 634 629 -85 0 629 634 623 -86 0 633 629 626 -87 0 626 629 623 -88 0 656 648 645 -89 0 625 628 622 -90 0 628 626 622 -91 0 622 626 614 -92 0 648 639 638 -93 0 654 656 645 -94 0 654 645 643 -95 0 664 654 666 -96 0 621 625 616 -97 0 639 632 630 -98 0 645 648 638 -99 0 645 638 631 -100 0 625 622 616 -101 0 616 622 614 -102 0 632 627 624 -103 0 617 621 611 -104 0 638 639 630 -105 0 638 630 631 -106 0 621 616 611 -107 0 611 616 606 -108 0 627 619 615 -109 0 643 658 654 -110 0 623 637 635 -111 0 630 632 624 -112 0 630 624 620 -113 0 612 617 608 -114 0 619 613 610 -115 0 624 627 615 -116 0 624 615 620 -117 0 617 611 608 -118 0 608 611 606 -119 0 609 612 602 -120 0 613 607 604 -121 0 614 626 623 -122 0 615 619 610 -123 0 615 610 605 -124 0 612 608 602 -125 0 602 608 595 -126 0 607 599 597 -127 0 603 609 596 -128 0 645 631 643 -129 0 643 631 635 -130 0 610 613 604 -131 0 610 604 605 -132 0 623 635 618 -133 0 599 592 588 -134 0 609 602 596 -135 0 596 602 595 -136 0 604 607 597 -137 0 604 597 590 -138 0 614 623 618 -139 0 598 603 594 -140 0 647 643 635 -141 0 592 585 582 -142 0 606 616 614 -143 0 597 599 588 -144 0 597 588 590 -145 0 630 620 631 -146 0 603 596 594 -147 0 594 596 583 -148 0 585 576 572 -149 0 593 598 584 -150 0 588 592 582 -151 0 588 582 574 -152 0 618 635 631 -153 0 576 567 562 -154 0 598 594 584 -155 0 584 594 583 -156 0 582 585 572 -157 0 582 572 574 -158 0 587 593 578 -159 0 615 605 620 -160 0 567 559 548 -161 0 595 608 606 -162 0 572 576 562 -163 0 572 562 554 -164 0 593 584 578 -165 0 578 584 568 -166 0 606 614 601 -167 0 559 545 536 -168 0 580 587 571 -169 0 631 620 618 -170 0 562 567 548 -171 0 562 548 543 -172 0 545 530 521 -173 0 604 590 605 -174 0 587 578 571 -175 0 571 578 560 -176 0 575 580 564 -177 0 548 559 536 -178 0 548 536 527 -179 0 530 519 507 -180 0 583 596 595 -181 0 588 574 590 -182 0 554 562 543 -183 0 554 543 534 -184 0 572 554 574 -185 0 568 584 583 -186 0 578 568 560 -187 0 560 568 547 -188 0 534 543 517 -189 0 554 534 552 -190 0 543 548 527 -191 0 543 527 517 -192 0 517 527 510 -193 0 560 547 538 -194 0 547 568 565 -195 0 536 545 521 -196 0 536 521 510 -197 0 569 575 557 -198 0 580 571 564 -199 0 564 571 549 -200 0 517 510 491 -201 0 510 527 536 -202 0 571 560 549 -203 0 549 560 538 -204 0 549 538 525 -205 0 519 502 494 -206 0 601 614 618 -207 0 606 601 589 -208 0 620 605 600 -209 0 564 549 544 -210 0 549 525 544 -211 0 544 525 518 -212 0 525 538 513 -213 0 521 530 507 -214 0 521 507 497 -215 0 544 518 537 -216 0 518 525 500 -217 0 575 564 557 -218 0 557 564 544 -219 0 557 544 537 -220 0 557 537 553 -221 0 497 507 481 -222 0 521 497 510 -223 0 507 519 494 -224 0 507 494 481 -225 0 481 494 466 -226 0 557 553 569 -227 0 569 553 563 -228 0 563 553 531 -229 0 531 553 537 -230 0 563 531 558 -231 0 481 466 452 -232 0 466 494 480 -233 0 595 606 589 -234 0 595 589 579 -235 0 579 589 573 -236 0 595 579 583 -237 0 554 552 574 -238 0 534 517 509 -239 0 552 534 526 -240 0 547 565 540 -241 0 538 547 523 -242 0 565 568 583 -243 0 491 510 473 -244 0 517 491 509 -245 0 494 502 480 -246 0 480 502 490 -247 0 480 490 463 -248 0 480 463 453 -249 0 463 490 475 -250 0 589 601 586 -251 0 620 600 618 -252 0 600 605 591 -253 0 525 513 500 -254 0 500 513 485 -255 0 485 513 498 -256 0 500 485 472 -257 0 513 538 523 -258 0 537 518 512 -259 0 518 500 493 -260 0 480 453 466 -261 0 466 453 438 -262 0 466 438 452 -263 0 452 438 424 -264 0 438 453 422 -265 0 424 438 403 -266 0 452 424 444 -267 0 422 453 443 -268 0 438 422 403 -269 0 403 422 390 -270 0 390 422 408 -271 0 403 390 369 -272 0 444 424 414 -273 0 452 444 471 -274 0 424 403 391 -275 0 453 463 443 -276 0 443 463 451 -277 0 451 463 475 -278 0 451 475 462 -279 0 443 451 421 -280 0 451 462 432 -281 0 443 421 408 -282 0 408 421 392 -283 0 408 392 373 -284 0 392 421 412 -285 0 443 408 422 -286 0 421 451 432 -287 0 421 432 412 -288 0 412 432 428 -289 0 412 428 398 -290 0 428 432 448 -291 0 428 448 440 -292 0 398 428 440 -293 0 412 398 374 -294 0 408 373 390 -295 0 390 373 358 -296 0 390 358 369 -297 0 369 358 335 -298 0 358 373 337 -299 0 369 335 361 -300 0 335 358 321 -301 0 392 412 374 -302 0 392 374 357 -303 0 357 374 339 -304 0 392 357 373 -305 0 337 373 357 -306 0 337 357 323 -307 0 337 323 303 -308 0 323 357 339 -309 0 323 339 304 -310 0 358 337 321 -311 0 321 337 303 -312 0 321 303 288 -313 0 288 303 271 -314 0 321 288 309 -315 0 432 462 448 -316 0 309 288 278 -317 0 321 309 335 -318 0 335 309 331 -319 0 335 331 361 -320 0 361 331 354 -321 0 331 309 297 -322 0 361 354 381 -323 0 354 331 311 -324 0 297 309 278 -325 0 297 278 265 -326 0 297 265 284 -327 0 265 278 247 -328 0 331 297 311 -329 0 284 265 256 -330 0 297 284 311 -331 0 311 284 308 -332 0 308 284 277 -333 0 311 308 340 -334 0 247 278 259 -335 0 265 247 233 -336 0 271 303 291 -337 0 288 271 259 -338 0 288 259 278 -339 0 259 271 234 -340 0 234 271 252 -341 0 259 234 232 -342 0 304 339 329 -343 0 323 304 291 -344 0 323 291 303 -345 0 291 304 272 -346 0 291 272 252 -347 0 272 304 293 -348 0 369 361 391 -349 0 391 361 381 -350 0 391 381 414 -351 0 414 381 387 -352 0 387 381 354 -353 0 414 387 431 -354 0 369 391 403 -355 0 277 284 256 -356 0 277 256 248 -357 0 277 248 270 -358 0 248 256 229 -359 0 340 308 334 -360 0 308 277 300 -361 0 311 340 354 -362 0 354 340 387 -363 0 431 387 416 -364 0 229 256 233 -365 0 229 233 208 -366 0 270 248 243 -367 0 414 431 444 -368 0 277 270 300 -369 0 300 270 298 -370 0 298 270 266 -371 0 300 298 327 -372 0 248 229 221 -373 0 266 270 243 -374 0 266 243 240 -375 0 266 240 263 -376 0 240 243 219 -377 0 300 327 334 -378 0 334 327 362 -379 0 298 266 290 -380 0 327 298 325 -381 0 334 362 367 -382 0 362 327 355 -383 0 240 219 214 -384 0 266 263 290 -385 0 290 263 289 -386 0 289 263 258 -387 0 290 289 319 -388 0 219 243 221 -389 0 219 221 198 -390 0 263 240 238 -391 0 497 481 471 -392 0 471 481 452 -393 0 497 471 473 -394 0 339 374 363 -395 0 289 258 287 -396 0 290 319 325 -397 0 325 319 352 -398 0 319 289 320 -399 0 258 263 238 -400 0 258 238 237 -401 0 237 238 213 -402 0 258 237 260 -403 0 579 573 561 -404 0 573 589 586 -405 0 573 586 570 -406 0 570 586 581 -407 0 573 570 556 -408 0 229 208 202 -409 0 208 233 218 -410 0 258 260 287 -411 0 287 260 292 -412 0 292 260 264 -413 0 287 292 318 -414 0 260 237 241 -415 0 213 238 214 -416 0 213 214 187 -417 0 237 213 212 -418 0 264 260 241 -419 0 264 241 242 -420 0 264 242 269 -421 0 242 241 216 -422 0 318 292 324 -423 0 198 221 202 -424 0 202 221 229 -425 0 198 202 178 -426 0 178 202 186 -427 0 198 178 175 -428 0 287 318 320 -429 0 320 318 346 -430 0 292 264 295 -431 0 219 198 192 -432 0 259 232 247 -433 0 247 232 218 -434 0 218 232 207 -435 0 207 232 234 -436 0 218 207 193 -437 0 234 252 226 -438 0 252 271 291 -439 0 269 242 246 -440 0 293 304 329 -441 0 534 509 526 -442 0 485 498 465 -443 0 581 586 600 -444 0 216 241 212 -445 0 216 212 190 -446 0 552 526 555 -447 0 352 319 345 -448 0 500 472 493 -449 0 493 472 464 -450 0 493 464 483 -451 0 464 472 446 -452 0 556 570 551 -453 0 264 269 295 -454 0 295 269 301 -455 0 301 269 276 -456 0 295 301 328 -457 0 272 293 249 -458 0 472 485 456 -459 0 570 581 566 -460 0 242 216 220 -461 0 325 352 355 -462 0 325 355 327 -463 0 355 352 379 -464 0 379 352 377 -465 0 355 379 382 -466 0 498 513 523 -467 0 498 523 511 -468 0 374 398 363 -469 0 363 398 396 -470 0 363 396 347 -471 0 396 398 440 -472 0 347 396 378 -473 0 363 347 329 -474 0 329 347 312 -475 0 329 312 293 -476 0 312 347 338 -477 0 338 347 378 -478 0 338 378 370 -479 0 370 378 418 -480 0 338 370 332 -481 0 312 338 305 -482 0 332 370 365 -483 0 338 332 305 -484 0 305 332 299 -485 0 299 332 326 -486 0 305 299 274 -487 0 326 332 365 -488 0 326 365 349 -489 0 349 365 401 -490 0 326 349 317 -491 0 299 326 294 -492 0 305 274 281 -493 0 274 299 268 -494 0 573 556 561 -495 0 561 556 541 -496 0 541 556 529 -497 0 561 541 540 -498 0 540 565 561 -499 0 511 523 540 -500 0 265 233 256 -501 0 218 193 208 -502 0 473 510 497 -503 0 523 547 540 -504 0 276 269 246 -505 0 276 246 253 -506 0 253 246 228 -507 0 276 253 282 -508 0 317 349 344 -509 0 328 301 333 -510 0 193 207 183 -511 0 498 511 482 -512 0 213 187 189 -513 0 301 276 307 -514 0 187 214 192 -515 0 192 214 219 -516 0 187 192 170 -517 0 187 170 165 -518 0 170 192 175 -519 0 170 175 150 -520 0 326 317 294 -521 0 294 317 285 -522 0 285 317 313 -523 0 294 285 261 -524 0 233 247 218 -525 0 491 473 455 -526 0 295 328 324 -527 0 324 328 356 -528 0 586 601 600 -529 0 313 317 344 -530 0 313 344 343 -531 0 313 343 310 -532 0 343 344 393 -533 0 334 308 300 -534 0 431 416 455 -535 0 282 253 262 -536 0 414 424 391 -537 0 340 334 367 -538 0 228 246 220 -539 0 228 220 201 -540 0 329 339 363 -541 0 261 285 267 -542 0 591 605 590 -543 0 150 175 154 -544 0 471 444 473 -545 0 541 529 514 -546 0 285 313 283 -547 0 243 248 221 -548 0 276 282 307 -549 0 307 282 316 -550 0 307 316 341 -551 0 316 282 296 -552 0 346 318 348 -553 0 253 228 231 -554 0 294 261 268 -555 0 268 261 239 -556 0 320 346 345 -557 0 320 345 319 -558 0 345 346 375 -559 0 375 346 376 -560 0 345 375 377 -561 0 377 375 411 -562 0 600 591 581 -563 0 581 577 566 -564 0 170 150 149 -565 0 529 556 551 -566 0 529 551 522 -567 0 529 522 508 -568 0 522 551 555 -569 0 416 387 367 -570 0 310 343 350 -571 0 175 178 154 -572 0 512 518 493 -573 0 355 382 362 -574 0 362 382 389 -575 0 362 389 367 -576 0 367 389 416 -577 0 389 382 415 -578 0 389 415 416 -579 0 415 382 410 -580 0 410 382 379 -581 0 410 379 409 -582 0 409 379 377 -583 0 409 377 411 -584 0 410 409 435 -585 0 410 435 439 -586 0 435 409 434 -587 0 415 410 439 -588 0 415 439 445 -589 0 415 445 416 -590 0 445 439 467 -591 0 467 439 461 -592 0 445 467 476 -593 0 439 435 461 -594 0 461 435 459 -595 0 461 459 484 -596 0 459 435 434 -597 0 459 434 460 -598 0 460 434 433 -599 0 459 460 492 -600 0 484 459 492 -601 0 484 492 514 -602 0 461 484 487 -603 0 492 460 482 -604 0 482 460 465 -605 0 482 465 498 -606 0 433 434 411 -607 0 433 411 406 -608 0 411 434 409 -609 0 406 411 375 -610 0 433 406 437 -611 0 406 375 376 -612 0 406 376 419 -613 0 419 376 380 -614 0 406 419 437 -615 0 437 419 456 -616 0 433 437 465 -617 0 460 433 465 -618 0 419 380 413 -619 0 380 376 348 -620 0 467 461 487 -621 0 467 487 499 -622 0 499 487 522 -623 0 467 499 476 -624 0 476 499 509 -625 0 487 484 508 -626 0 508 484 514 -627 0 508 514 529 -628 0 316 296 330 -629 0 493 483 512 -630 0 238 240 214 -631 0 307 341 333 -632 0 333 341 366 -633 0 190 212 189 -634 0 189 212 213 -635 0 190 189 167 -636 0 167 189 165 -637 0 167 165 146 -638 0 190 167 173 -639 0 483 464 454 -640 0 186 202 208 -641 0 186 208 193 -642 0 325 298 290 -643 0 464 446 426 -644 0 341 316 353 -645 0 313 310 283 -646 0 283 310 279 -647 0 198 175 192 -648 0 537 512 531 -649 0 508 522 487 -650 0 446 472 456 -651 0 446 456 419 -652 0 296 282 262 -653 0 296 262 273 -654 0 296 273 306 -655 0 273 262 245 -656 0 245 262 231 -657 0 245 231 217 -658 0 273 245 254 -659 0 306 273 286 -660 0 296 306 330 -661 0 330 306 342 -662 0 342 306 322 -663 0 330 342 364 -664 0 216 190 197 -665 0 178 186 162 -666 0 377 352 345 -667 0 320 289 287 -668 0 268 239 244 -669 0 378 396 427 -670 0 322 306 286 -671 0 322 286 302 -672 0 322 302 336 -673 0 302 286 275 -674 0 322 336 359 -675 0 336 302 315 -676 0 315 302 280 -677 0 280 302 275 -678 0 280 275 251 -679 0 251 275 254 -680 0 336 315 351 -681 0 336 351 368 -682 0 368 351 386 -683 0 368 386 402 -684 0 336 368 359 -685 0 359 368 394 -686 0 394 368 402 -687 0 394 402 425 -688 0 359 394 372 -689 0 425 402 436 -690 0 394 425 407 -691 0 402 386 420 -692 0 402 420 436 -693 0 436 420 449 -694 0 436 449 468 -695 0 436 468 450 -696 0 468 449 479 -697 0 359 372 342 -698 0 342 372 364 -699 0 364 372 400 -700 0 364 400 384 -701 0 400 372 407 -702 0 400 407 429 -703 0 429 407 442 -704 0 400 429 417 -705 0 359 342 322 -706 0 407 372 394 -707 0 400 417 384 -708 0 384 417 404 -709 0 384 404 371 -710 0 404 417 441 -711 0 417 429 447 -712 0 429 442 458 -713 0 442 407 425 -714 0 442 425 450 -715 0 442 450 470 -716 0 450 425 436 -717 0 442 470 458 -718 0 458 470 488 -719 0 488 470 496 -720 0 458 488 474 -721 0 470 450 478 -722 0 458 474 447 -723 0 447 474 469 -724 0 496 470 478 -725 0 496 478 505 -726 0 496 505 535 -727 0 505 478 489 -728 0 474 488 504 -729 0 488 496 516 -730 0 478 450 468 -731 0 478 468 489 -732 0 489 468 479 -733 0 489 479 506 -734 0 489 506 505 -735 0 447 469 441 -736 0 447 441 417 -737 0 469 474 495 -738 0 371 404 399 -739 0 404 441 430 -740 0 384 371 353 -741 0 353 371 341 -742 0 341 371 366 -743 0 384 353 364 -744 0 505 506 533 -745 0 364 353 330 -746 0 254 275 286 -747 0 474 504 495 -748 0 495 504 524 -749 0 495 524 515 -750 0 524 504 542 -751 0 515 524 550 -752 0 495 515 486 -753 0 488 516 504 -754 0 447 429 458 -755 0 516 496 535 -756 0 366 371 399 -757 0 366 399 395 -758 0 366 395 360 -759 0 395 399 423 -760 0 360 395 383 -761 0 423 399 430 -762 0 423 430 454 -763 0 395 423 426 -764 0 366 360 333 -765 0 333 360 328 -766 0 328 360 356 -767 0 356 360 383 -768 0 356 383 380 -769 0 380 383 413 -770 0 469 495 486 -771 0 469 486 457 -772 0 457 486 477 -773 0 469 457 441 -774 0 477 486 503 -775 0 457 477 454 -776 0 486 515 503 -777 0 503 515 528 -778 0 503 528 531 -779 0 528 515 550 -780 0 477 503 501 -781 0 187 165 189 -782 0 404 430 399 -783 0 383 395 426 -784 0 241 237 212 -785 0 201 220 197 -786 0 197 220 216 -787 0 201 197 177 -788 0 177 197 173 -789 0 177 173 155 -790 0 201 177 181 -791 0 167 146 151 -792 0 146 165 149 -793 0 149 165 170 -794 0 146 149 128 -795 0 128 149 131 -796 0 146 128 126 -797 0 128 131 110 -798 0 146 126 151 -799 0 131 149 150 -800 0 131 150 134 -801 0 131 134 114 -802 0 134 150 154 -803 0 134 154 138 -804 0 134 138 117 -805 0 138 154 162 -806 0 131 114 110 -807 0 110 114 94 -808 0 94 114 99 -809 0 110 94 93 -810 0 114 134 117 -811 0 114 117 99 -812 0 99 117 105 -813 0 99 105 87 -814 0 105 117 124 -815 0 105 124 112 -816 0 99 87 81 -817 0 87 105 89 -818 0 124 117 138 -819 0 124 138 142 -820 0 142 138 162 -821 0 142 162 166 -822 0 124 142 132 -823 0 142 166 152 -824 0 166 162 186 -825 0 124 132 112 -826 0 112 132 120 -827 0 120 132 141 -828 0 112 120 100 -829 0 132 142 152 -830 0 132 152 141 -831 0 141 152 163 -832 0 163 152 166 -833 0 141 163 157 -834 0 141 157 133 -835 0 157 163 180 -836 0 120 141 133 -837 0 120 133 109 -838 0 109 133 123 -839 0 120 109 100 -840 0 112 100 89 -841 0 89 100 82 -842 0 82 100 92 -843 0 89 82 73 -844 0 93 94 77 -845 0 94 99 81 -846 0 94 81 77 -847 0 77 81 65 -848 0 110 93 111 -849 0 73 82 64 -850 0 92 100 109 -851 0 92 109 104 -852 0 92 104 86 -853 0 104 109 123 -854 0 104 123 119 -855 0 92 86 74 -856 0 86 104 98 -857 0 123 133 145 -858 0 104 119 98 -859 0 119 123 140 -860 0 89 73 87 -861 0 82 92 74 -862 0 82 74 64 -863 0 64 74 59 -864 0 64 59 48 -865 0 59 74 72 -866 0 64 48 57 -867 0 72 74 86 -868 0 72 86 83 -869 0 72 83 67 -870 0 83 86 98 -871 0 83 98 95 -872 0 83 95 76 -873 0 95 98 113 -874 0 72 67 58 -875 0 67 83 76 -876 0 67 76 61 -877 0 67 61 52 -878 0 61 76 68 -879 0 113 98 119 -880 0 113 119 136 -881 0 136 119 140 -882 0 136 140 158 -883 0 113 136 130 -884 0 95 113 107 -885 0 76 95 90 -886 0 158 140 161 -887 0 130 136 153 -888 0 52 61 50 -889 0 136 158 153 -890 0 113 130 107 -891 0 107 130 127 -892 0 107 127 102 -893 0 127 130 148 -894 0 127 148 143 -895 0 148 130 153 -896 0 148 153 168 -897 0 148 168 164 -898 0 168 153 176 -899 0 176 153 158 -900 0 176 158 179 -901 0 179 158 161 -902 0 176 179 200 -903 0 179 161 184 -904 0 148 164 143 -905 0 168 176 191 -906 0 164 168 188 -907 0 67 52 58 -908 0 58 52 45 -909 0 58 45 59 -910 0 45 52 40 -911 0 48 59 45 -912 0 58 59 72 -913 0 180 163 183 -914 0 183 163 166 -915 0 157 180 169 -916 0 133 157 145 -917 0 145 157 169 -918 0 145 169 161 -919 0 161 169 184 -920 0 200 179 203 -921 0 176 200 191 -922 0 191 200 209 -923 0 209 200 223 -924 0 191 209 211 -925 0 211 209 239 -926 0 239 209 223 -927 0 191 211 188 -928 0 188 211 210 -929 0 223 200 203 -930 0 223 203 230 -931 0 230 203 215 -932 0 223 230 244 -933 0 223 244 239 -934 0 230 215 249 -935 0 215 203 184 -936 0 215 184 194 -937 0 215 194 222 -938 0 194 184 169 -939 0 188 210 195 -940 0 210 211 235 -941 0 179 184 203 -942 0 40 52 50 -943 0 45 40 31 -944 0 65 81 70 -945 0 90 95 107 -946 0 77 65 62 -947 0 76 90 84 -948 0 84 90 102 -949 0 215 222 249 -950 0 81 87 70 -951 0 70 87 73 -952 0 70 73 57 -953 0 89 105 112 -954 0 222 205 226 -955 0 222 226 252 -956 0 111 93 96 -957 0 188 168 191 -958 0 126 128 111 -959 0 111 128 110 -960 0 126 111 108 -961 0 108 111 96 -962 0 108 96 97 -963 0 108 97 116 -964 0 97 96 78 -965 0 126 108 129 -966 0 108 116 129 -967 0 129 116 137 -968 0 137 116 118 -969 0 129 137 155 -970 0 116 97 101 -971 0 78 96 79 -972 0 97 78 80 -973 0 137 118 139 -974 0 118 116 101 -975 0 118 101 106 -976 0 106 101 88 -977 0 118 106 125 -978 0 125 106 115 -979 0 88 101 80 -980 0 118 125 139 -981 0 139 125 147 -982 0 139 147 160 -983 0 147 125 135 -984 0 106 88 91 -985 0 147 135 159 -986 0 144 135 122 -987 0 122 135 115 -988 0 122 115 103 -989 0 103 115 91 -990 0 103 91 85 -991 0 85 91 75 -992 0 115 135 125 -993 0 75 91 88 -994 0 75 88 71 -995 0 85 75 69 -996 0 69 75 60 -997 0 71 88 80 -998 0 71 80 66 -999 0 71 66 55 -1000 0 66 80 78 -1001 0 75 71 60 -1002 0 60 71 55 -1003 0 60 55 47 -1004 0 47 55 43 -1005 0 60 47 51 -1006 0 51 47 39 -1007 0 39 47 34 -1008 0 69 60 51 -1009 0 39 34 28 -1010 0 34 47 43 -1011 0 34 43 32 -1012 0 32 43 41 -1013 0 34 32 24 -1014 0 55 66 49 -1015 0 160 147 174 -1016 0 139 160 156 -1017 0 43 55 49 -1018 0 43 49 41 -1019 0 41 49 53 -1020 0 41 53 42 -1021 0 53 49 63 -1022 0 42 53 54 -1023 0 41 42 30 -1024 0 63 49 66 -1025 0 63 66 78 -1026 0 63 78 79 -1027 0 53 63 62 -1028 0 53 62 54 -1029 0 54 62 65 -1030 0 54 65 56 -1031 0 56 65 70 -1032 0 56 70 57 -1033 0 54 56 44 -1034 0 56 57 46 -1035 0 62 63 79 -1036 0 54 44 42 -1037 0 42 44 33 -1038 0 42 33 30 -1039 0 30 33 22 -1040 0 33 44 35 -1041 0 30 22 21 -1042 0 22 33 26 -1043 0 44 56 46 -1044 0 44 46 35 -1045 0 35 46 37 -1046 0 37 46 48 -1047 0 35 37 29 -1048 0 29 37 36 -1049 0 35 29 26 -1050 0 35 26 33 -1051 0 126 129 151 -1052 0 21 22 14 -1053 0 30 21 32 -1054 0 32 21 24 -1055 0 24 21 16 -1056 0 30 32 41 -1057 0 24 16 19 -1058 0 16 21 14 -1059 0 16 14 9 -1060 0 16 9 11 -1061 0 9 14 10 -1062 0 10 14 17 -1063 0 9 10 4 -1064 0 22 26 17 -1065 0 22 17 14 -1066 0 17 26 20 -1067 0 20 26 29 -1068 0 17 20 13 -1069 0 34 24 28 -1070 0 29 36 25 -1071 0 31 36 45 -1072 0 45 36 48 -1073 0 101 97 80 -1074 0 79 96 93 -1075 0 79 93 77 -1076 0 79 77 62 -1077 0 36 37 48 -1078 0 48 46 57 -1079 0 137 139 156 -1080 0 137 156 155 -1081 0 155 156 177 -1082 0 115 106 91 -1083 0 174 147 159 -1084 0 156 160 181 -1085 0 160 174 185 -1086 0 13 20 15 -1087 0 17 13 10 -1088 0 10 13 7 -1089 0 7 13 8 -1090 0 10 7 4 -1091 0 4 7 3 -1092 0 7 8 6 -1093 0 8 13 15 -1094 0 8 15 12 -1095 0 239 261 235 -1096 0 164 188 195 -1097 0 324 356 348 -1098 0 324 348 318 -1099 0 348 356 380 -1100 0 376 346 348 -1101 0 430 441 457 -1102 0 430 457 454 -1103 0 228 201 206 -1104 0 579 561 565 -1105 0 324 292 295 -1106 0 274 268 244 -1107 0 551 570 566 -1108 0 210 235 236 -1109 0 73 64 57 -1110 0 246 242 220 -1111 0 217 231 206 -1112 0 206 231 228 -1113 0 217 206 185 -1114 0 245 217 227 -1115 0 183 207 205 -1116 0 161 140 145 -1117 0 299 294 268 -1118 0 555 526 522 -1119 0 333 301 307 -1120 0 312 305 281 -1121 0 312 281 293 -1122 0 293 281 249 -1123 0 123 145 140 -1124 0 419 413 446 -1125 0 201 181 206 -1126 0 482 511 492 -1127 0 169 180 194 -1128 0 491 455 476 -1129 0 173 167 151 -1130 0 173 151 155 -1131 0 155 151 129 -1132 0 190 173 197 -1133 0 344 349 397 -1134 0 181 177 156 -1135 0 193 183 166 -1136 0 193 166 186 -1137 0 455 473 431 -1138 0 281 274 255 -1139 0 552 555 574 -1140 0 9 4 5 -1141 0 456 485 465 -1142 0 365 370 405 -1143 0 234 205 207 -1144 0 235 211 239 -1145 0 262 253 231 -1146 0 476 455 445 -1147 0 210 236 224 -1148 0 224 236 250 -1149 0 250 236 257 -1150 0 257 236 235 -1151 0 250 257 279 -1152 0 286 273 254 -1153 0 245 227 254 -1154 0 254 227 251 -1155 0 178 162 154 -1156 0 426 446 413 -1157 0 255 274 244 -1158 0 267 285 283 -1159 0 174 159 182 -1160 0 272 222 252 -1161 0 272 249 222 -1162 0 454 464 426 -1163 0 160 185 181 -1164 0 181 185 206 -1165 0 353 316 330 -1166 0 445 455 416 -1167 0 477 501 483 -1168 0 483 501 512 -1169 0 512 501 531 -1170 0 31 40 27 -1171 0 185 174 199 -1172 0 261 267 235 -1173 0 235 267 257 -1174 0 257 267 283 -1175 0 257 283 279 -1176 0 483 454 477 -1177 0 159 135 144 -1178 0 159 144 172 -1179 0 159 172 182 -1180 0 182 172 196 -1181 0 182 196 204 -1182 0 182 204 199 -1183 0 199 204 227 -1184 0 227 204 225 -1185 0 204 196 225 -1186 0 227 217 199 -1187 0 541 514 520 -1188 0 15 20 25 -1189 0 501 503 531 -1190 0 281 255 249 -1191 0 249 255 230 -1192 0 230 255 244 -1193 0 25 20 29 -1194 0 385 350 388 -1195 0 18 12 15 -1196 0 8 12 6 -1197 0 19 28 24 -1198 0 143 121 127 -1199 0 127 121 102 -1200 0 199 174 182 -1201 0 1 2 3 -1202 0 506 532 533 -1203 0 68 50 61 -1204 0 68 76 84 -1205 0 314 279 310 -1206 0 314 310 350 -1207 0 6 3 7 -1208 0 205 234 226 -1209 0 205 222 194 -1210 0 520 514 492 -1211 0 195 171 164 -1212 0 164 171 143 -1213 0 5 11 9 -1214 0 541 520 540 -1215 0 540 520 511 -1216 0 511 520 492 -1217 0 38 27 40 -1218 0 38 40 50 -1219 0 15 25 23 -1220 0 15 23 18 -1221 0 18 23 27 -1222 0 27 23 31 -1223 0 23 25 31 -1224 0 31 25 36 -1225 0 185 199 217 -1226 0 224 195 210 -1227 0 2 5 4 -1228 0 225 251 227 -1229 0 11 19 16 -1230 0 183 205 180 -1231 0 180 205 194 -1232 0 401 397 349 -1233 0 440 427 396 -1234 0 418 405 370 -1235 0 393 388 343 -1236 0 427 418 378 -1237 0 397 393 344 -1238 0 405 401 365 -1239 0 542 546 524 -1240 0 550 558 528 -1241 0 535 539 516 -1242 0 546 550 524 -1243 0 533 535 505 -1244 0 539 542 516 -1245 0 454 426 423 -1246 0 531 528 558 -1247 0 551 566 555 -1248 0 456 465 437 -1249 0 102 90 107 -1250 0 591 590 577 -1251 0 591 577 581 -1252 0 566 577 555 -1253 0 577 590 574 -1254 0 583 579 565 -1255 0 413 383 426 -1256 0 509 491 476 -1257 0 504 516 542 -1258 0 618 600 601 -1259 0 340 367 387 -1260 0 444 431 473 -1261 0 526 509 499 -1262 0 2 4 3 -1263 0 555 577 574 -1264 0 343 388 350 -1265 0 499 522 526 -End Elements - - -Begin Conditions Condition2D -1266 0 1 3 -1267 0 3 6 -1268 0 6 12 -1269 0 12 18 -1270 0 18 27 -1271 0 27 38 -1272 0 38 50 -1273 0 50 68 -1274 0 68 84 -1275 0 84 102 -1276 0 102 121 -1277 0 121 143 -1278 0 143 171 -1279 0 171 195 -1280 0 195 224 -1281 0 224 250 -1282 0 250 279 -1283 0 279 314 -1284 0 314 350 -1285 0 350 385 -1286 0 385 388 -1287 0 388 393 -1288 0 393 397 -1289 0 397 401 -1290 0 401 405 -1291 0 405 418 -1292 0 418 427 -1293 0 427 440 -1294 0 440 448 -1295 0 448 462 -1296 0 462 475 -1297 0 475 490 -1298 0 490 502 -1299 0 502 519 -1300 0 519 530 -1301 0 530 545 -1302 0 545 559 -1303 0 559 567 -1304 0 567 576 -1305 0 576 585 -1306 0 585 592 -1307 0 592 599 -1308 0 599 607 -1309 0 607 613 -1310 0 613 619 -1311 0 619 627 -1312 0 627 632 -1313 0 632 639 -1314 0 639 648 -1315 0 648 656 -1316 0 656 664 -1317 0 664 673 -1318 0 673 681 -1319 0 532 506 -1320 0 506 479 -1321 0 479 449 -1322 0 449 420 -1323 0 420 386 -1324 0 386 351 -1325 0 351 315 -1326 0 315 280 -1327 0 280 251 -1328 0 251 225 -1329 0 225 196 -1330 0 196 172 -1331 0 172 144 -1332 0 144 122 -1333 0 122 103 -1334 0 103 85 -1335 0 85 69 -1336 0 69 51 -1337 0 51 39 -1338 0 39 28 -1339 0 28 19 -1340 0 19 11 -1341 0 11 5 -1342 0 5 2 -1343 0 2 1 -1344 0 681 686 -1345 0 686 689 -1346 0 689 691 -1347 0 691 690 -1348 0 690 688 -1349 0 688 685 -1350 0 685 682 -1351 0 682 678 -1352 0 678 672 -1353 0 672 665 -1354 0 665 660 -1355 0 660 651 -1356 0 651 642 -1357 0 642 636 -1358 0 636 633 -1359 0 633 628 -1360 0 628 625 -1361 0 625 621 -1362 0 621 617 -1363 0 617 612 -1364 0 612 609 -1365 0 609 603 -1366 0 603 598 -1367 0 598 593 -1368 0 593 587 -1369 0 587 580 -1370 0 580 575 -1371 0 575 569 -1372 0 569 563 -1373 0 563 558 -1374 0 558 550 -1375 0 550 546 -1376 0 546 542 -1377 0 542 539 -1378 0 539 535 -1379 0 535 533 -1380 0 533 532 -End Conditions - - -Begin NodalData VELOCITY_X -660 1 0.500000 -665 1 0.500000 -672 1 0.500000 -678 1 0.500000 -682 1 0.500000 -685 1 0.500000 -688 1 0.500000 -690 1 0.500000 -691 1 0.500000 -End NodalData - -Begin NodalData VELOCITY_Y -660 1 0.000000 -665 1 0.000000 -672 1 0.000000 -678 1 0.000000 -682 1 0.000000 -685 1 0.000000 -688 1 0.000000 -690 1 0.000000 -691 1 0.000000 -End NodalData - -Begin NodalData VELOCITY_Z -660 1 0.000000 -665 1 0.000000 -672 1 0.000000 -678 1 0.000000 -682 1 0.000000 -685 1 0.000000 -688 1 0.000000 -690 1 0.000000 -691 1 0.000000 -End NodalData - -Begin NodalData PRESSURE -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -5 1 0.000000 -6 1 0.000000 -11 1 0.000000 -12 1 0.000000 -18 1 0.000000 -19 1 0.000000 -27 1 0.000000 -28 1 0.000000 -38 1 0.000000 -39 1 0.000000 -50 1 0.000000 -51 1 0.000000 -68 1 0.000000 -69 1 0.000000 -84 1 0.000000 -85 1 0.000000 -102 1 0.000000 -103 1 0.000000 -121 1 0.000000 -122 1 0.000000 -143 1 0.000000 -144 1 0.000000 -171 1 0.000000 -172 1 0.000000 -195 1 0.000000 -196 1 0.000000 -224 1 0.000000 -225 1 0.000000 -250 1 0.000000 -251 1 0.000000 -279 1 0.000000 -280 1 0.000000 -314 1 0.000000 -315 1 0.000000 -350 1 0.000000 -351 1 0.000000 -385 1 0.000000 -386 1 0.000000 -420 1 0.000000 -449 1 0.000000 -479 1 0.000000 -506 1 0.000000 -532 1 0.000000 -End NodalData - -Begin NodalData DISTANCE -636 0 -1.000000 -640 0 -1.000000 -642 0 -1.000000 -644 0 -1.000000 -646 0 -1.000000 -649 0 -1.000000 -650 0 -1.000000 -651 0 -1.000000 -653 0 -1.000000 -655 0 -1.000000 -657 0 -1.000000 -659 0 -1.000000 -660 0 -1.000000 -661 0 -1.000000 -662 0 -1.000000 -663 0 -1.000000 -665 0 -1.000000 -667 0 -1.000000 -668 0 -1.000000 -669 0 -1.000000 -670 0 -1.000000 -671 0 -1.000000 -672 0 -1.000000 -674 0 -1.000000 -675 0 -1.000000 -676 0 -1.000000 -677 0 -1.000000 -678 0 -1.000000 -679 0 -1.000000 -680 0 -1.000000 -681 0 -1.000000 -682 0 -1.000000 -683 0 -1.000000 -684 0 -1.000000 -685 0 -1.000000 -686 0 -1.000000 -687 0 -1.000000 -688 0 -1.000000 -689 0 -1.000000 -690 0 -1.000000 -691 0 -1.000000 -End NodalData - - - -Begin ConditionalData IS_STRUCTURE -1286 1.000000 -1287 1.000000 -1288 1.000000 -1289 1.000000 -1290 1.000000 -1291 1.000000 -1292 1.000000 -1293 1.000000 -1294 1.000000 -1295 1.000000 -1296 1.000000 -1297 1.000000 -1298 1.000000 -1299 1.000000 -1300 1.000000 -1301 1.000000 -1302 1.000000 -1303 1.000000 -1304 1.000000 -1305 1.000000 -1306 1.000000 -1307 1.000000 -1308 1.000000 -1309 1.000000 -1310 1.000000 -1311 1.000000 -1312 1.000000 -1313 1.000000 -1314 1.000000 -1315 1.000000 -1316 1.000000 -1317 1.000000 -1318 1.000000 -1344 1.000000 -1345 1.000000 -1346 1.000000 -1355 1.000000 -1356 1.000000 -1357 1.000000 -1358 1.000000 -1359 1.000000 -1360 1.000000 -1361 1.000000 -1362 1.000000 -1363 1.000000 -1364 1.000000 -1365 1.000000 -1366 1.000000 -1367 1.000000 -1368 1.000000 -1369 1.000000 -1370 1.000000 -1371 1.000000 -1372 1.000000 -1373 1.000000 -1374 1.000000 -1375 1.000000 -1376 1.000000 -1377 1.000000 -1378 1.000000 -1379 1.000000 -1380 1.000000 -End ConditionalData - diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.msh b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.msh deleted file mode 100644 index ae24c60a1f11..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.msh and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.node b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.node deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.png b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.png deleted file mode 100644 index b8daee8d5275..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.png and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.prb b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.prb deleted file mode 100644 index efd2ea48277b..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.prb +++ /dev/null @@ -1,72 +0,0 @@ -PROBLEM DATA -BOOK: Default Elements -QUESTION: 2D_Boundary_Condition#CB#(Condition2D) -VALUE: Condition2D -QUESTION: 3D_Boundary_Condition#CB#(Condition3D) -VALUE: Condition3D -QUESTION: 2D_Body_Element#CB#(Fluid2D) -VALUE: Fluid2D -QUESTION: 3D_Body_Element#CB#(Fluid3D) -VALUE: Fluid3D -BOOK: Problem Parameters -QUESTION: Python_script_file#CB#(Use_Default,Do_not_write,Copy_From,Use_Current) -VALUE: Use_Default -DEPENDENCIES: (Use_Default,SET,Python_file,#CURRENT#)(Do_not_write,SET,Python_file,#CURRENT#)(Copy_From,RESTORE,Python_file,#CURRENT#)(Use_Current,SET,Python_file,#CURRENT#) -QUESTION: Python_file -VALUE: script.py -TKWIDGET: TkwidgetFilePath -QUESTION: Transfer_materials_to_lower_entities#CB#(1,0) -VALUE: 1 -QUESTION: Let_GiD_determine_domain_size#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (1,HIDE,DOMAIN_SIZE,#CURRENT#)(0,RESTORE,DOMAIN_SIZE,#CURRENT#) -QUESTION: DOMAIN_SIZE#CB#(2,3) -VALUE: 2 -STATE: HIDDEN -QUESTION: max_time -VALUE: 5.0 -QUESTION: safety_factor -VALUE: 0.5 -QUESTION: max_time_step -VALUE: 0.001 -QUESTION: output_dt -VALUE: 0.5 -QUESTION: density -VALUE: 1000.0 -QUESTION: viscosity -VALUE: 0.000001 -QUESTION: body_force_x -VALUE: 0.0 -QUESTION: body_force_y -VALUE: -9.81 -QUESTION: body_force_z -VALUE: 0.0 -QUESTION: wall_law_y -VALUE: 0.0 -QUESTION: print_layers -VALUE: True -QUESTION: use_mass_correction -VALUE: True -QUESTION: redistance_frequency -VALUE: 5 -QUESTION: extrapolation_layers -VALUE: 5 -QUESTION: number_of_inital_steps -VALUE: 10 -QUESTION: initial_time_step -VALUE: 0.00001 -QUESTION: reduction_on_failure -VALUE: 0.3 -QUESTION: stabdt_pressure_factor -VALUE: 1.0 -QUESTION: stabdt_convection_factor -VALUE: 0.01 -QUESTION: tau2_factor -VALUE: 1.0 -QUESTION: edge_detection_angle -VALUE: 45.0 -QUESTION: assume_constant_pressure -VALUE: False -END PROBLEM DATA -INTERVAL DATA -END INTERVAL DATA diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.prop b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.prop deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.rdr b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.rdr deleted file mode 100644 index ea11fa082101..000000000000 Binary files a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed.rdr and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed_out.mdpa b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_fixed_out.mdpa deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_out.mdpa b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/Coupled_slope2dNonNewt_out.mdpa deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/edgebased_levelset_var.py b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/edgebased_levelset_var.py deleted file mode 100644 index e4053e2ce9f0..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/edgebased_levelset_var.py +++ /dev/null @@ -1,30 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -domain_size = 2 - -max_time = 5.0 -safety_factor = 0.5 -max_time_step = 0.001 -output_dt = 0.5 -density = 1000.0 -viscosity = 0.000001 -body_force_x = 0.0 -body_force_y = -9.81 -body_force_z = 0.0 -wall_law_y = 0.0 -print_layers = True -use_mass_correction = True -redistance_frequency = 5 -extrapolation_layers = 5 -number_of_inital_steps = 10 -initial_time_step = 0.00001 -reduction_on_failure = 0.3 -stabdt_pressure_factor = 1.0 -stabdt_convection_factor = 0.01 -tau2_factor = 1.0 -edge_detection_angle = 45.0 -assume_constant_pressure = False -# Declare Python Variables - -problem_name = "Coupled_slope2dNonNewt_fixed" -problem_path = "/home/antonia/kratos/applications/PFEMapplication/test_exemples/Coupled_slope2dNonNewt_fixed.gid" -kratos_path = "/home/antonia/kratos" diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/pfem_nonewtonian_coupled_var.py b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/pfem_nonewtonian_coupled_var.py deleted file mode 100644 index de9d954ad578..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/pfem_nonewtonian_coupled_var.py +++ /dev/null @@ -1,34 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -domain_size = 2 - -Density = 1300.0 -Viscosity = 0.0001 -Gravity_X = 0.0 -Gravity_Y = -9.806 -Gravity_Z = 0.0 -Porosity = 0.5 -Diameter = 0.01 -YieldStress = 3000.0 -max_x = 2.5 -max_y = 3.0 -max_z = 1.0 -min_x = -1.0 -min_y = -1.0 -min_z = -1.0 -use_oss = 0 -dynamic_tau = 1 -nsteps = 10000 -output_Dt = 0.1 -min_dt = 0.01 -max_dt = 0.1 -safety_factor = 0.1 -SolverType = "monolithic_solver_lagrangian" -laplacian_form = 3 -fluid_file = r'/home/antonia/kratos/applications/PFEMapplication/test_exemples/Coupled_slope2dNonNewt_fixed.gid/Coupled_slope2dNonNewt_fixed.mdpa' -fluid_file = fluid_file[0:fluid_file.rindex('.mdpa')] -fluid_file = fluid_file.replace('/', '//') -# Declare Python Variables - -problem_name = "Coupled_slope2dNonNewt" -problem_path = "/home/antonia/kratos/applications/PFEMapplication/test_exemples/Coupled_slope2dNonNewt.gid" -kratos_path = "/home/antonia/kratos" diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/pfem_nonewtonian_coupled_var_benchmark.py b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/pfem_nonewtonian_coupled_var_benchmark.py deleted file mode 100644 index f442e7e3f84e..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/pfem_nonewtonian_coupled_var_benchmark.py +++ /dev/null @@ -1,32 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -domain_size = 2 - -Density = 1300.0 -Viscosity = 0.0001 -Gravity_X = 0.0 -Gravity_Y = -9.806 -Gravity_Z = 0.0 -Porosity = 0.5 -Diameter = 0.01 -YieldStress = 3000.0 -max_x = 2.5 -max_y = 3.0 -max_z = 1.0 -min_x = -1.0 -min_y = -1.0 -min_z = -1.0 -use_oss = 0 -dynamic_tau = 1 -nsteps = 1000 -output_Dt = 0.5 -min_dt = 0.01 -max_dt = 0.1 -safety_factor = 0.1 -SolverType = "monolithic_solver_lagrangian" -laplacian_form = 3 -fluid_file = r'Coupled_slope2dNonNewt_fixed' -# Declare Python Variables - -problem_name = "Coupled_slope2dNonNewt" -problem_path = "." -kratos_path = "../../../.." diff --git a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/script.py b/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/script.py deleted file mode 100644 index 23eba9f8f73b..000000000000 --- a/applications/PFEMapplication/test_examples/Coupled_slope2dNonNewt.gid/script.py +++ /dev/null @@ -1,424 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# import the configuration data as read from the GiD -import pfem_nonewtonian_coupled_var -import time -# -# -# setting the domain size for the problem to be solved -domain_size = pfem_nonewtonian_coupled_var.domain_size - -# read from pfem_nonewtonian_coupled_var name and path of fluid_gid_problem -# Acuario version********************************* -# fluid_path='/home/antonia/EXAMPLES/Erosion/WorkingErosCFixed.gid/' - - -fluid_path = pfem_nonewtonian_coupled_var.fluid_file.rpartition('/') -fluid_path = fluid_path[0] - -# -# -# ATTENTION: here the order is important - -# including kratos path -import sys -sys.path.append(pfem_nonewtonian_coupled_var.kratos_path) - -from KratosMultiphysics import * - -from KratosMultiphysics.StructuralApplication import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * -from KratosMultiphysics.ExternalSolversApplication import* - - -# from now on the order is not anymore crucial -# -# -import math -import edgebased_levelset_var -import edgebased_levelset_solver - -# import cProfile - -# defining the two model part: pfem_model_part and fixed_model_part -pfem_model_part = ModelPart("PfemFluidPart") -fixed_model_part = ModelPart("FixedFluidPart") - -# importing the fluid_solver files and adding the variablesv -edgebased_levelset_solver.AddVariables(fixed_model_part) -fixed_model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) -fixed_model_part.AddNodalSolutionStepVariable(POROSITY) -fixed_model_part.AddNodalSolutionStepVariable(DIAMETER) -# fixed_model_part.AddNodalSolutionStepVariable(SEEPAGE_DRAG) -# fixed_model_part.AddNodalSolutionStepVariable(VISCOSITY) - -# importing the structural_solver files and adding the variables -SolverType = pfem_nonewtonian_coupled_var.SolverType -if(SolverType == "pfem_solver_ale"): - print("Pfem_solver_ale_not supported. Check to be using nonewtonian_asgs2d (or 3d) element") -elif(SolverType == "monolithic_solver_lagrangian"): - import monolithic_solver_lagrangian_nonnewtonian - monolithic_solver_lagrangian_nonnewtonian.AddVariables(pfem_model_part) - pfem_model_part.AddNodalSolutionStepVariable(FLAG_VARIABLE) - pfem_model_part.AddNodalSolutionStepVariable(IS_VISITED) - pfem_model_part.AddNodalSolutionStepVariable(IS_EROSIONABLE) - pfem_model_part.AddNodalSolutionStepVariable(FRICTION_COEFFICIENT) - pfem_model_part.AddNodalSolutionStepVariable(POROSITY) - pfem_model_part.AddNodalSolutionStepVariable(NODAL_MASS) - pfem_model_part.AddNodalSolutionStepVariable(DIAMETER) -# pfem_model_part.AddNodalSolutionStepVariable(SEEPAGE_DRAG) - pfem_model_part.AddNodalSolutionStepVariable(WATER_PRESSURE) -else: - raise "solver type not supported: options are FractionalStep - Monolithic" - - -# reading the models -name_pfem = pfem_nonewtonian_coupled_var.problem_name -name_fixed = pfem_nonewtonian_coupled_var.fluid_file - - -gid_mode = GiDPostMode.GiD_PostBinary -multifile = MultiFileFlag.MultipleFiles -deformed_mesh_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteElementsOnly - -# READING FROM MULTIPLE .gid FILES######################## -# reading the pfem model part -gid_io = EdgebasedGidIO(name_pfem, gid_mode, multifile, deformed_mesh_flag, write_conditions) -model_part_io_structure = ModelPartIO(name_pfem) -model_part_io_structure.ReadModelPart(pfem_model_part) -print("pfem model read correctly") -# reading the fixed model part with the new porblem type format -model_part_io_fluid = ModelPartIO(name_fixed) -model_part_io_fluid.ReadModelPart(fixed_model_part) -print("fixed model read correctly") - -# NODAL CONDITIONS of the PFEM model -for node in pfem_model_part.Nodes: - node.SetSolutionStepValue(DENSITY, 0, pfem_nonewtonian_coupled_var.Density) - node.SetSolutionStepValue(VISCOSITY, 0, pfem_nonewtonian_coupled_var.Viscosity) - node.SetSolutionStepValue(POROSITY, 0, pfem_nonewtonian_coupled_var.Porosity) - node.SetSolutionStepValue(DIAMETER, 0, pfem_nonewtonian_coupled_var.Diameter) - node.SetSolutionStepValue(BODY_FORCE_X, 0, pfem_nonewtonian_coupled_var.Gravity_X) - node.SetSolutionStepValue(BODY_FORCE_Y, 0, pfem_nonewtonian_coupled_var.Gravity_Y) - node.SetSolutionStepValue(BODY_FORCE_Z, 0, pfem_nonewtonian_coupled_var.Gravity_Z) - node.SetSolutionStepValue(YIELD_STRESS, 0, pfem_nonewtonian_coupled_var.YieldStress) - - -edgebased_levelset_solver.AddDofs(fixed_model_part) - -# NODAL CONDITIONS of the FIXED model -# we assume here that all of the internal nodes are marked with a negative distance -# set the distance of all of the internal nodes to a small value -small_value = 0.0001 -n_active = 0 -for node in fixed_model_part.Nodes: - dist = node.GetSolutionStepValue(DISTANCE) - if(dist < 0.0): - n_active = n_active + 1 - node.SetSolutionStepValue(DISTANCE, 0, -small_value) - else: - node.SetSolutionStepValue(DISTANCE, 0, small_value) -if(n_active == 0): - raise "ERROR. At least one node has to be initialized with a distance lesser than 0" - -# make sure that the porosity is not zero on any node (set by default to fluid only) -for node in fixed_model_part.Nodes: - if(node.GetSolutionStepValue(POROSITY) == 0.0): - node.SetSolutionStepValue(POROSITY, 0, 1.0) - if(node.GetSolutionStepValue(DIAMETER) == 0.0): - node.SetSolutionStepValue(DIAMETER, 0, 1.0) - -# print pfem_model_part -# print pfem_model_part.Properties - -# setting the limits of the bounding box -box_corner1 = Vector(3) -box_corner1[0] = pfem_nonewtonian_coupled_var.min_x -box_corner1[1] = pfem_nonewtonian_coupled_var.min_y -box_corner1[2] = pfem_nonewtonian_coupled_var.min_z -box_corner2 = Vector(3) -box_corner2[0] = pfem_nonewtonian_coupled_var.max_x -box_corner2[1] = pfem_nonewtonian_coupled_var.max_y; -box_corner2[2] = pfem_nonewtonian_coupled_var.max_z; - -# time setting -output_dt = pfem_nonewtonian_coupled_var.output_Dt -max_dt = pfem_nonewtonian_coupled_var.max_dt -min_dt = pfem_nonewtonian_coupled_var.min_dt -safety_factor = pfem_nonewtonian_coupled_var.safety_factor -nsteps = pfem_nonewtonian_coupled_var.nsteps - -# the buffer size should be set up here after the mesh is read for the first time -pfem_model_part.SetBufferSize(2) -fixed_model_part.SetBufferSize(2) - - -# constructing the fluid_solver (FIXED) -body_force = Vector(3) -body_force[0] = pfem_nonewtonian_coupled_var.Gravity_X -body_force[1] = pfem_nonewtonian_coupled_var.Gravity_Y -body_force[2] = pfem_nonewtonian_coupled_var.Gravity_Z - -viscosity = edgebased_levelset_var.viscosity -# print "***************** VISCOSITY *********************" -# print viscosity -density = edgebased_levelset_var.density -# print "***************** DENSITY *********************" -# print density -fluid_solver = edgebased_levelset_solver.EdgeBasedLevelSetSolver(fixed_model_part, domain_size, body_force, viscosity, density) - -fluid_solver.redistance_frequency = edgebased_levelset_var.redistance_frequency -fluid_solver.extrapolation_layers = edgebased_levelset_var.extrapolation_layers -fluid_solver.stabdt_pressure_factor = edgebased_levelset_var.stabdt_pressure_factor -fluid_solver.stabdt_convection_factor = edgebased_levelset_var.stabdt_convection_factor -fluid_solver.tau2_factor = edgebased_levelset_var.tau2_factor -fluid_solver.edge_detection_angle = edgebased_levelset_var.edge_detection_angle -fluid_solver.assume_constant_pressure = edgebased_levelset_var.assume_constant_pressure - -fluid_solver.Initialize() - -if(edgebased_levelset_var.wall_law_y > 1e-10): - fluid_solver.fluid_solver.ActivateWallResistance(edgebased_levelset_var.wall_law_y); - -# - -if(SolverType == "pfem_solver_ale"): - # adding dofs - print("pfem_solver_ale is being used whereas with erosion module only monolithic solver lagrangian is allowed. Check also to be using use asgs2d!!") -elif(SolverType == "monolithic_solver_lagrangian"): - # adding dofs - monolithic_solver_lagrangian_nonnewtonian.AddDofs(pfem_model_part) - structural_solver = monolithic_solver_lagrangian_nonnewtonian.MonolithicSolver(pfem_model_part, domain_size, box_corner1, box_corner2) - oss_swith = pfem_nonewtonian_coupled_var.use_oss - dynamic_tau = pfem_nonewtonian_coupled_var.dynamic_tau - pfem_model_part.ProcessInfo.SetValue(OSS_SWITCH, oss_swith); - pfem_model_part.ProcessInfo.SetValue(DYNAMIC_TAU, dynamic_tau); - # structural_solver.linear_solver = SuperLUSolver() - structural_solver.Initialize(output_dt) - - -if (domain_size == 3): - ProjectionModule = MeshTransfer3D(); - ErosionModule = ErosionUtils3D(); -else: - ProjectionModule = MeshTransfer2D(); - ErosionModule = ErosionUtils2D(); -PfemUtils = PfemUtils(); -DragUtils = DragUtils(); - -# To be inserted in the problem type######## -critical_vel = Vector(3); -critical_vel[0] = 0.06; -critical_vel[1] = 0.0; -critical_vel[2] = 0.0; -critical_en = 0.000001; -# - -ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, POROSITY, POROSITY); -ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, DIAMETER, DIAMETER); -for node in fixed_model_part.Nodes: - if(node.GetSolutionStepValue(POROSITY) == 0.0): - node.SetSolutionStepValue(POROSITY, 0, 1.0) - if(node.GetSolutionStepValue(DIAMETER) == 0.0): - node.SetSolutionStepValue(DIAMETER, 0, 1.0) -# bool to decide to solve or not the pfem model -calculate_dam = True - -# settings to be changed edgebased FIXED -max_Dt = edgebased_levelset_var.max_time_step -initial_Dt_ls = 0.001 * max_Dt -final_time = edgebased_levelset_var.max_time -safety_factor = edgebased_levelset_var.safety_factor - -number_of_inital_steps = edgebased_levelset_var.number_of_inital_steps -initial_time_step = edgebased_levelset_var.initial_time_step -out = 0 - -original_max_dt = max_Dt -Time = 0.0 -step = 0 -next_output_time = output_dt -max_safety_factor = safety_factor - -substep_number = 10 -substep_counter = 0 - -while(Time < final_time): -# print "line49" - - if(step < number_of_inital_steps): - max_Dt = initial_time_step - else: - max_Dt = original_max_dt - # progressively increment the safety factor - # in the steps that follow a reduction of it - safety_factor = safety_factor * 1.2 - if(safety_factor > max_safety_factor): - safety_factor = max_safety_factor - - Dt = fluid_solver.EstimateTimeStep(safety_factor, max_Dt) - - Time = Time + Dt - fixed_model_part.CloneTimeStep(Time) - - # let's do this later ... only each substep_number fluid solutions - # pfem_model_part.CloneTimeStep(Time) - - print("******** CURRENT TIME = ", Time) - - if(step > 3): - if(calculate_dam): - # (origin_model_part, destination_model_part, origin_variable_destination_variable) - ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, POROSITY, POROSITY); - ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, DIAMETER, DIAMETER); - - for node in fixed_model_part.Nodes: - if(node.GetSolutionStepValue(POROSITY) == 0.0): - node.SetSolutionStepValue(POROSITY, 0, 1.0) - if(node.GetSolutionStepValue(DIAMETER) == 0.0): - node.SetSolutionStepValue(DIAMETER, 0, 1.0) - - # solving the fluid problem ........................................................................................... - print("starting solving fluid edgebased~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~") - fluid_solver.Solve(); - print("finished solving fluid edgebased") - - print("start checking the time stepping") - check_dt = fluid_solver.EstimateTimeStep(0.95, max_Dt) - - if(check_dt < Dt): - print("***********************************************************") - print("***********************************************************") - print("***********************************************************") - print(" *** REDUCING THE TIME STEP ***") - print("***********************************************************") - print("***********************************************************") - print("***********************************************************") - - # we found a velocity too large! we need to reduce the time step - fluid_solver.fluid_solver.ReduceTimeStep(fixed_model_part, Time) # this is to set the database to the value at the beginning of the step - - safety_factor *= edgebased_levelset_var.reduction_on_failure - reduced_dt = fluid_solver.EstimateTimeStep(safety_factor, max_Dt) - - print("time before reduction= ", Time) - Time = Time - Dt + reduced_dt - print("reduced time = ", Time) - print("Dt = ", Dt) - print("reduced_dt = ", reduced_dt) - - fluid_solver.fluid_solver.ReduceTimeStep(fixed_model_part, Time) # this is to set the database to the value at the beginning of the step - fluid_solver.Solve() - print("finished checking the time stepping") - print(fixed_model_part) - - if(substep_counter == substep_number): - substep_counter = 0 - - pfem_model_part.CloneTimeStep(Time) - - print(pfem_model_part) - # solving the structural problem ........................................................................................... - print("starting solving structure~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~") - PfemUtils.CalculateNodalMass(pfem_model_part, domain_size) -# COMMENTING OUT provisionally BEGIN -# print "starting EROSION" -# structural_solver.neigh_finder.Execute(); -# print "founded neighbours" -# calculate_dam = ErosionModule.CheckErosionableNodes(fixed_model_part, pfem_model_part, critical_vel, critical_en, viscosity, density); -# print "finished EROSION" -# COMMENTING OUT provisionally END - - if(calculate_dam): - # Projecting the water pressure - ProjectionModule.DirectScalarVarInterpolation(fixed_model_part, pfem_model_part, PRESSURE, WATER_PRESSURE); - -# COMMENTING OUT provisionally BEGIN - # Adding Darcy non linear term to the external forces -# DragUtils.CalculateFluidDrag(fixed_model_part, SEEPAGE_DRAG, viscosity) -# ProjectionModule.DirectVectorialVarInterpolation(fixed_model_part, pfem_model_part, SEEPAGE_DRAG, SEEPAGE_DRAG); -# DragUtils.AddDrag(pfem_model_part, SEEPAGE_DRAG, BODY_FORCE, body_force) -# COMMENTING OUT provisionally END - - # PFEM steps - structural_solver.Remesh(); - print("Remesh in done!") - (structural_solver.solver).Solve(); - print("Solve in done!") - (structural_solver.solver).Clear(); - - print("finished solving structure") - # ErosionModule.SetErosionableNodes(pfem_model_part); - # if (Time>0.25): - # ProjectionModule.DirectScalarVarInterpolation(pfem_model_part, fixed_model_part, POROSITY); - # for node in fixed_model_part.Nodes: - # if( node.GetSolutionStepValue(POROSITY) == 0.5): - # print node.Id - - if (Time > 9.0): - substep_number = 2 - substep_counter += 1 - -# - if(Time >= next_output_time): - # a change in the output name is needed!!!! - - res_name1 = str(name_fixed) - gid_io.ChangeOutputName(res_name1) - gid_io.InitializeMesh(Time); - gid_io.WriteMesh(fixed_model_part.GetMesh()) - gid_io.FinalizeMesh(); - gid_io.InitializeResults(Time, fixed_model_part.GetMesh()) -# print "structure output ****************************************************" - gid_io.WriteNodalResults(VELOCITY, fixed_model_part.Nodes, Time, 0) -# gid_io.WriteNodalResults(CONV_VELOCITY,fixed_model_part.Nodes,Time,0) - gid_io.WriteNodalResults(PRESSURE, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DISTANCE, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(PRESS_PROJ, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(POROSITY, fixed_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DIAMETER, fixed_model_part.Nodes, Time, 0) -# gid_io.WriteNodalResults(SEEPAGE_DRAG,fixed_model_part.Nodes,Time,0) - - gid_io.Flush() - gid_io.FinalizeResults() - - res_name2 = str(name_pfem) - gid_io.ChangeOutputName(res_name2) - gid_io.InitializeMesh(Time); - gid_io.WriteNodeMesh(pfem_model_part.GetMesh()); - gid_io.WriteMesh(pfem_model_part.GetMesh()) - gid_io.FinalizeMesh(); - - gid_io.InitializeResults(Time, pfem_model_part.GetMesh()) -# print "fluid output ****************************************************" - gid_io.WriteNodalResults(VELOCITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(PRESSURE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_FREE_SURFACE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_BOUNDARY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(IS_STRUCTURE, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(VISCOSITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DENSITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(BODY_FORCE, pfem_model_part.Nodes, Time, 0) -# gid_io.WriteNodalResults(FRICTION_COEFFICIENT,pfem_model_part.Nodes,Time,0) -# gid_io.WriteNodalResults(IS_EROSIONABLE,pfem_model_part.Nodes,Time,0) - gid_io.WriteNodalResults(POROSITY, pfem_model_part.Nodes, Time, 0) - gid_io.WriteNodalResults(DIAMETER, pfem_model_part.Nodes, Time, 0) -# gid_io.WriteNodalResults(SEEPAGE_DRAG,pfem_model_part.Nodes,Time,0) - gid_io.WriteNodalResults(WATER_PRESSURE, pfem_model_part.Nodes, Time, 0) - gid_io.PrintOnGaussPoints(TEMPERATURE, pfem_model_part, Time) - gid_io.PrintOnGaussPoints(AUX_INDEX, pfem_model_part, Time) - - gid_io.Flush() - gid_io.FinalizeResults() - - next_output_time = Time + output_dt - - out = 0 - - out = out + 1 - step = step + 1 - print("step finished") - -print("solution finished") diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.cnd b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.cnd deleted file mode 100644 index c2b01f166aad..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.cnd +++ /dev/null @@ -1,458 +0,0 @@ -BOOK:Fluid_Boundary_Conditions -NUMBER: 1 CONDITION: point_BODY_FORCE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 2 CONDITION: line_BODY_FORCE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 3 CONDITION: surface_BODY_FORCE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 4 CONDITION: volume_BODY_FORCE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 5 CONDITION: point_VELOCITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 6 CONDITION: line_VELOCITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 7 CONDITION: surface_VELOCITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 8 CONDITION: volume_VELOCITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 9 CONDITION: point_DISPLACEMENT_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 10 CONDITION: line_DISPLACEMENT_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 11 CONDITION: surface_DISPLACEMENT_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 12 CONDITION: volume_DISPLACEMENT_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 13 CONDITION: point_HEAT_FLUX_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 14 CONDITION: line_HEAT_FLUX_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 15 CONDITION: surface_HEAT_FLUX_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 16 CONDITION: volume_HEAT_FLUX_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 17 CONDITION: point_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 18 CONDITION: line_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 19 CONDITION: surface_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 20 CONDITION: volume_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 21 CONDITION: point_CONDUCTIVITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 22 CONDITION: line_CONDUCTIVITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 23 CONDITION: surface_CONDUCTIVITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 24 CONDITION: volume_CONDUCTIVITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 25 CONDITION: point_TEMPERATURE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 26 CONDITION: line_TEMPERATURE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 27 CONDITION: surface_TEMPERATURE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 28 CONDITION: volume_TEMPERATURE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 29 CONDITION: point_IS_STRUCTURE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 30 CONDITION: line_IS_STRUCTURE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 31 CONDITION: surface_IS_STRUCTURE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 32 CONDITION: volume_IS_STRUCTURE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 33 CONDITION: point_DENSITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 34 CONDITION: line_DENSITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 35 CONDITION: surface_DENSITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 36 CONDITION: volume_DENSITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 37 CONDITION: point_VISCOSITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 38 CONDITION: line_VISCOSITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 39 CONDITION: surface_VISCOSITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 40 CONDITION: volume_VISCOSITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 41 CONDITION: point_PRESSURE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 42 CONDITION: line_PRESSURE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 43 CONDITION: surface_PRESSURE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 44 CONDITION: volume_PRESSURE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -BOOK:Fluid_Element_Type -NUMBER: 45 CONDITION: volume_ConvDiff3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(ConvDiff3D) -VALUE: ConvDiff3D -END CONDITION -NUMBER: 46 CONDITION: surface_ConvDiff2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(ConvDiff2D) -VALUE: ConvDiff2D -END CONDITION -NUMBER: 47 CONDITION: volume_Fluid3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Fluid3D) -VALUE: Fluid3D -END CONDITION -NUMBER: 48 CONDITION: surface_Fluid2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Fluid2D) -VALUE: Fluid2D -END CONDITION -NUMBER: 49 CONDITION: surface_Condition3D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Condition3D) -VALUE: Condition3D -END CONDITION -NUMBER: 50 CONDITION: line_Condition2D -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Condition2D) -VALUE: Condition2D -END CONDITION diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.cond b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.cond deleted file mode 100644 index d733fdb6ef7e..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.cond +++ /dev/null @@ -1,457 +0,0 @@ - - -// Fixing degrees of freedom in nodes - -NODES[1].Fix(IS_STRUCTURE); -NODES[2].Fix(IS_STRUCTURE); -NODES[3].Fix(IS_STRUCTURE); -NODES[4].Fix(IS_STRUCTURE); -NODES[5].Fix(IS_STRUCTURE); -NODES[6].Fix(IS_STRUCTURE); -NODES[7].Fix(IS_STRUCTURE); -NODES[8].Fix(IS_STRUCTURE); -NODES[9].Fix(IS_STRUCTURE); -NODES[10].Fix(IS_STRUCTURE); -NODES[11].Fix(IS_STRUCTURE); -NODES[12].Fix(IS_STRUCTURE); -NODES[13].Fix(IS_STRUCTURE); -NODES[14].Fix(IS_STRUCTURE); -NODES[15].Fix(IS_STRUCTURE); -NODES[16].Fix(IS_STRUCTURE); -NODES[17].Fix(IS_STRUCTURE); -NODES[18].Fix(IS_STRUCTURE); -NODES[19].Fix(IS_STRUCTURE); -NODES[20].Fix(IS_STRUCTURE); -NODES[21].Fix(IS_STRUCTURE); -NODES[22].Fix(IS_STRUCTURE); -NODES[23].Fix(IS_STRUCTURE); -NODES[24].Fix(IS_STRUCTURE); -NODES[25].Fix(IS_STRUCTURE); -NODES[26].Fix(IS_STRUCTURE); -NODES[27].Fix(IS_STRUCTURE); -NODES[28].Fix(IS_STRUCTURE); -NODES[29].Fix(IS_STRUCTURE); -NODES[30].Fix(IS_STRUCTURE); -NODES[31].Fix(IS_STRUCTURE); -NODES[32].Fix(IS_STRUCTURE); -NODES[33].Fix(IS_STRUCTURE); -NODES[34].Fix(IS_STRUCTURE); -NODES[35].Fix(IS_STRUCTURE); -NODES[36].Fix(IS_STRUCTURE); -NODES[38].Fix(IS_STRUCTURE); -NODES[44].Fix(IS_STRUCTURE); -NODES[50].Fix(IS_STRUCTURE); -NODES[58].Fix(IS_STRUCTURE); -NODES[70].Fix(IS_STRUCTURE); -NODES[83].Fix(IS_STRUCTURE); -NODES[96].Fix(IS_STRUCTURE); -NODES[113].Fix(IS_STRUCTURE); -NODES[133].Fix(IS_STRUCTURE); -NODES[151].Fix(IS_STRUCTURE); -NODES[174].Fix(IS_STRUCTURE); -NODES[200].Fix(IS_STRUCTURE); -NODES[228].Fix(IS_STRUCTURE); -NODES[258].Fix(IS_STRUCTURE); -NODES[288].Fix(IS_STRUCTURE); -NODES[289].Fix(IS_STRUCTURE); -NODES[290].Fix(IS_STRUCTURE); -NODES[291].Fix(IS_STRUCTURE); -NODES[292].Fix(IS_STRUCTURE); -NODES[293].Fix(IS_STRUCTURE); -NODES[296].Fix(IS_STRUCTURE); -NODES[297].Fix(IS_STRUCTURE); -NODES[299].Fix(IS_STRUCTURE); -NODES[300].Fix(IS_STRUCTURE); -NODES[303].Fix(IS_STRUCTURE); -NODES[304].Fix(IS_STRUCTURE); -NODES[312].Fix(IS_STRUCTURE); -NODES[313].Fix(IS_STRUCTURE); -NODES[317].Fix(IS_STRUCTURE); -NODES[318].Fix(IS_STRUCTURE); -NODES[326].Fix(IS_STRUCTURE); -NODES[327].Fix(IS_STRUCTURE); -NODES[331].Fix(IS_STRUCTURE); -NODES[332].Fix(IS_STRUCTURE); -NODES[338].Fix(IS_STRUCTURE); -NODES[339].Fix(IS_STRUCTURE); -NODES[347].Fix(IS_STRUCTURE); -NODES[348].Fix(IS_STRUCTURE); -NODES[358].Fix(IS_STRUCTURE); -NODES[359].Fix(IS_STRUCTURE); -NODES[368].Fix(IS_STRUCTURE); -NODES[369].Fix(IS_STRUCTURE); -NODES[379].Fix(IS_STRUCTURE); -NODES[380].Fix(IS_STRUCTURE); -NODES[391].Fix(IS_STRUCTURE); -NODES[392].Fix(IS_STRUCTURE); -NODES[404].Fix(IS_STRUCTURE); -NODES[405].Fix(IS_STRUCTURE); -NODES[415].Fix(IS_STRUCTURE); -NODES[416].Fix(IS_STRUCTURE); -NODES[430].Fix(IS_STRUCTURE); -NODES[431].Fix(IS_STRUCTURE); -NODES[445].Fix(IS_STRUCTURE); -NODES[446].Fix(IS_STRUCTURE); -NODES[462].Fix(IS_STRUCTURE); -NODES[463].Fix(IS_STRUCTURE); -NODES[479].Fix(IS_STRUCTURE); -NODES[480].Fix(IS_STRUCTURE); -NODES[496].Fix(IS_STRUCTURE); -NODES[497].Fix(IS_STRUCTURE); -NODES[515].Fix(IS_STRUCTURE); -NODES[516].Fix(IS_STRUCTURE); -NODES[533].Fix(IS_STRUCTURE); -NODES[534].Fix(IS_STRUCTURE); -NODES[554].Fix(IS_STRUCTURE); -NODES[555].Fix(IS_STRUCTURE); -NODES[574].Fix(IS_STRUCTURE); -NODES[575].Fix(IS_STRUCTURE); -NODES[590].Fix(IS_STRUCTURE); -NODES[591].Fix(IS_STRUCTURE); -NODES[610].Fix(IS_STRUCTURE); -NODES[611].Fix(IS_STRUCTURE); -NODES[626].Fix(IS_STRUCTURE); -NODES[627].Fix(IS_STRUCTURE); -NODES[646].Fix(IS_STRUCTURE); -NODES[647].Fix(IS_STRUCTURE); -NODES[662].Fix(IS_STRUCTURE); -NODES[663].Fix(IS_STRUCTURE); -NODES[679].Fix(IS_STRUCTURE); -NODES[680].Fix(IS_STRUCTURE); -NODES[695].Fix(IS_STRUCTURE); -NODES[696].Fix(IS_STRUCTURE); -NODES[713].Fix(IS_STRUCTURE); -NODES[714].Fix(IS_STRUCTURE); -NODES[726].Fix(IS_STRUCTURE); -NODES[727].Fix(IS_STRUCTURE); -NODES[741].Fix(IS_STRUCTURE); -NODES[742].Fix(IS_STRUCTURE); -NODES[754].Fix(IS_STRUCTURE); -NODES[755].Fix(IS_STRUCTURE); -NODES[769].Fix(IS_STRUCTURE); -NODES[770].Fix(IS_STRUCTURE); -NODES[779].Fix(IS_STRUCTURE); -NODES[780].Fix(IS_STRUCTURE); -NODES[791].Fix(IS_STRUCTURE); -NODES[792].Fix(IS_STRUCTURE); -NODES[802].Fix(IS_STRUCTURE); -NODES[803].Fix(IS_STRUCTURE); -NODES[811].Fix(IS_STRUCTURE); -NODES[812].Fix(IS_STRUCTURE); -NODES[820].Fix(IS_STRUCTURE); -NODES[821].Fix(IS_STRUCTURE); -NODES[827].Fix(IS_STRUCTURE); -NODES[828].Fix(IS_STRUCTURE); -NODES[834].Fix(IS_STRUCTURE); -NODES[835].Fix(IS_STRUCTURE); -NODES[839].Fix(IS_STRUCTURE); -NODES[840].Fix(IS_STRUCTURE); -NODES[844].Fix(IS_STRUCTURE); -NODES[845].Fix(IS_STRUCTURE); -NODES[848].Fix(IS_STRUCTURE); -NODES[849].Fix(IS_STRUCTURE); -NODES[850].Fix(IS_STRUCTURE); -NODES[851].Fix(IS_STRUCTURE); -NODES[852].Fix(IS_STRUCTURE); -NODES[1].Fix(VELOCITY_X); -NODES[1].Fix(VELOCITY_Y); -NODES[2].Fix(VELOCITY_X); -NODES[2].Fix(VELOCITY_Y); -NODES[3].Fix(VELOCITY_X); -NODES[3].Fix(VELOCITY_Y); -NODES[4].Fix(VELOCITY_X); -NODES[4].Fix(VELOCITY_Y); -NODES[5].Fix(VELOCITY_X); -NODES[5].Fix(VELOCITY_Y); -NODES[6].Fix(VELOCITY_X); -NODES[6].Fix(VELOCITY_Y); -NODES[7].Fix(VELOCITY_X); -NODES[7].Fix(VELOCITY_Y); -NODES[8].Fix(VELOCITY_X); -NODES[8].Fix(VELOCITY_Y); -NODES[9].Fix(VELOCITY_X); -NODES[9].Fix(VELOCITY_Y); -NODES[10].Fix(VELOCITY_X); -NODES[10].Fix(VELOCITY_Y); -NODES[11].Fix(VELOCITY_X); -NODES[11].Fix(VELOCITY_Y); -NODES[12].Fix(VELOCITY_X); -NODES[12].Fix(VELOCITY_Y); -NODES[13].Fix(VELOCITY_X); -NODES[13].Fix(VELOCITY_Y); -NODES[14].Fix(VELOCITY_X); -NODES[14].Fix(VELOCITY_Y); -NODES[15].Fix(VELOCITY_X); -NODES[15].Fix(VELOCITY_Y); -NODES[16].Fix(VELOCITY_X); -NODES[16].Fix(VELOCITY_Y); -NODES[17].Fix(VELOCITY_X); -NODES[17].Fix(VELOCITY_Y); -NODES[18].Fix(VELOCITY_X); -NODES[18].Fix(VELOCITY_Y); -NODES[19].Fix(VELOCITY_X); -NODES[19].Fix(VELOCITY_Y); -NODES[20].Fix(VELOCITY_X); -NODES[20].Fix(VELOCITY_Y); -NODES[21].Fix(VELOCITY_X); -NODES[21].Fix(VELOCITY_Y); -NODES[22].Fix(VELOCITY_X); -NODES[22].Fix(VELOCITY_Y); -NODES[23].Fix(VELOCITY_X); -NODES[23].Fix(VELOCITY_Y); -NODES[24].Fix(VELOCITY_X); -NODES[24].Fix(VELOCITY_Y); -NODES[25].Fix(VELOCITY_X); -NODES[25].Fix(VELOCITY_Y); -NODES[26].Fix(VELOCITY_X); -NODES[26].Fix(VELOCITY_Y); -NODES[27].Fix(VELOCITY_X); -NODES[27].Fix(VELOCITY_Y); -NODES[28].Fix(VELOCITY_X); -NODES[28].Fix(VELOCITY_Y); -NODES[29].Fix(VELOCITY_X); -NODES[29].Fix(VELOCITY_Y); -NODES[30].Fix(VELOCITY_X); -NODES[30].Fix(VELOCITY_Y); -NODES[31].Fix(VELOCITY_X); -NODES[31].Fix(VELOCITY_Y); -NODES[32].Fix(VELOCITY_X); -NODES[32].Fix(VELOCITY_Y); -NODES[33].Fix(VELOCITY_X); -NODES[33].Fix(VELOCITY_Y); -NODES[34].Fix(VELOCITY_X); -NODES[34].Fix(VELOCITY_Y); -NODES[35].Fix(VELOCITY_X); -NODES[35].Fix(VELOCITY_Y); -NODES[36].Fix(VELOCITY_X); -NODES[36].Fix(VELOCITY_Y); -NODES[38].Fix(VELOCITY_X); -NODES[38].Fix(VELOCITY_Y); -NODES[44].Fix(VELOCITY_X); -NODES[44].Fix(VELOCITY_Y); -NODES[50].Fix(VELOCITY_X); -NODES[50].Fix(VELOCITY_Y); -NODES[58].Fix(VELOCITY_X); -NODES[58].Fix(VELOCITY_Y); -NODES[70].Fix(VELOCITY_X); -NODES[70].Fix(VELOCITY_Y); -NODES[83].Fix(VELOCITY_X); -NODES[83].Fix(VELOCITY_Y); -NODES[96].Fix(VELOCITY_X); -NODES[96].Fix(VELOCITY_Y); -NODES[113].Fix(VELOCITY_X); -NODES[113].Fix(VELOCITY_Y); -NODES[133].Fix(VELOCITY_X); -NODES[133].Fix(VELOCITY_Y); -NODES[151].Fix(VELOCITY_X); -NODES[151].Fix(VELOCITY_Y); -NODES[174].Fix(VELOCITY_X); -NODES[174].Fix(VELOCITY_Y); -NODES[200].Fix(VELOCITY_X); -NODES[200].Fix(VELOCITY_Y); -NODES[228].Fix(VELOCITY_X); -NODES[228].Fix(VELOCITY_Y); -NODES[258].Fix(VELOCITY_X); -NODES[258].Fix(VELOCITY_Y); -NODES[288].Fix(VELOCITY_X); -NODES[288].Fix(VELOCITY_Y); -NODES[289].Fix(VELOCITY_X); -NODES[289].Fix(VELOCITY_Y); -NODES[290].Fix(VELOCITY_X); -NODES[290].Fix(VELOCITY_Y); -NODES[291].Fix(VELOCITY_X); -NODES[291].Fix(VELOCITY_Y); -NODES[292].Fix(VELOCITY_X); -NODES[292].Fix(VELOCITY_Y); -NODES[293].Fix(VELOCITY_X); -NODES[293].Fix(VELOCITY_Y); -NODES[296].Fix(VELOCITY_X); -NODES[296].Fix(VELOCITY_Y); -NODES[297].Fix(VELOCITY_X); -NODES[297].Fix(VELOCITY_Y); -NODES[299].Fix(VELOCITY_X); -NODES[299].Fix(VELOCITY_Y); -NODES[300].Fix(VELOCITY_X); -NODES[300].Fix(VELOCITY_Y); -NODES[303].Fix(VELOCITY_X); -NODES[303].Fix(VELOCITY_Y); -NODES[304].Fix(VELOCITY_X); -NODES[304].Fix(VELOCITY_Y); -NODES[312].Fix(VELOCITY_X); -NODES[312].Fix(VELOCITY_Y); -NODES[313].Fix(VELOCITY_X); -NODES[313].Fix(VELOCITY_Y); -NODES[317].Fix(VELOCITY_X); -NODES[317].Fix(VELOCITY_Y); -NODES[318].Fix(VELOCITY_X); -NODES[318].Fix(VELOCITY_Y); -NODES[326].Fix(VELOCITY_X); -NODES[326].Fix(VELOCITY_Y); -NODES[327].Fix(VELOCITY_X); -NODES[327].Fix(VELOCITY_Y); -NODES[331].Fix(VELOCITY_X); -NODES[331].Fix(VELOCITY_Y); -NODES[332].Fix(VELOCITY_X); -NODES[332].Fix(VELOCITY_Y); -NODES[338].Fix(VELOCITY_X); -NODES[338].Fix(VELOCITY_Y); -NODES[339].Fix(VELOCITY_X); -NODES[339].Fix(VELOCITY_Y); -NODES[347].Fix(VELOCITY_X); -NODES[347].Fix(VELOCITY_Y); -NODES[348].Fix(VELOCITY_X); -NODES[348].Fix(VELOCITY_Y); -NODES[358].Fix(VELOCITY_X); -NODES[358].Fix(VELOCITY_Y); -NODES[359].Fix(VELOCITY_X); -NODES[359].Fix(VELOCITY_Y); -NODES[368].Fix(VELOCITY_X); -NODES[368].Fix(VELOCITY_Y); -NODES[369].Fix(VELOCITY_X); -NODES[369].Fix(VELOCITY_Y); -NODES[379].Fix(VELOCITY_X); -NODES[379].Fix(VELOCITY_Y); -NODES[380].Fix(VELOCITY_X); -NODES[380].Fix(VELOCITY_Y); -NODES[391].Fix(VELOCITY_X); -NODES[391].Fix(VELOCITY_Y); -NODES[392].Fix(VELOCITY_X); -NODES[392].Fix(VELOCITY_Y); -NODES[404].Fix(VELOCITY_X); -NODES[404].Fix(VELOCITY_Y); -NODES[405].Fix(VELOCITY_X); -NODES[405].Fix(VELOCITY_Y); -NODES[415].Fix(VELOCITY_X); -NODES[415].Fix(VELOCITY_Y); -NODES[416].Fix(VELOCITY_X); -NODES[416].Fix(VELOCITY_Y); -NODES[430].Fix(VELOCITY_X); -NODES[430].Fix(VELOCITY_Y); -NODES[431].Fix(VELOCITY_X); -NODES[431].Fix(VELOCITY_Y); -NODES[445].Fix(VELOCITY_X); -NODES[445].Fix(VELOCITY_Y); -NODES[446].Fix(VELOCITY_X); -NODES[446].Fix(VELOCITY_Y); -NODES[462].Fix(VELOCITY_X); -NODES[462].Fix(VELOCITY_Y); -NODES[463].Fix(VELOCITY_X); -NODES[463].Fix(VELOCITY_Y); -NODES[479].Fix(VELOCITY_X); -NODES[479].Fix(VELOCITY_Y); -NODES[480].Fix(VELOCITY_X); -NODES[480].Fix(VELOCITY_Y); -NODES[496].Fix(VELOCITY_X); -NODES[496].Fix(VELOCITY_Y); -NODES[497].Fix(VELOCITY_X); -NODES[497].Fix(VELOCITY_Y); -NODES[515].Fix(VELOCITY_X); -NODES[515].Fix(VELOCITY_Y); -NODES[516].Fix(VELOCITY_X); -NODES[516].Fix(VELOCITY_Y); -NODES[533].Fix(VELOCITY_X); -NODES[533].Fix(VELOCITY_Y); -NODES[534].Fix(VELOCITY_X); -NODES[534].Fix(VELOCITY_Y); -NODES[554].Fix(VELOCITY_X); -NODES[554].Fix(VELOCITY_Y); -NODES[555].Fix(VELOCITY_X); -NODES[555].Fix(VELOCITY_Y); -NODES[574].Fix(VELOCITY_X); -NODES[574].Fix(VELOCITY_Y); -NODES[575].Fix(VELOCITY_X); -NODES[575].Fix(VELOCITY_Y); -NODES[590].Fix(VELOCITY_X); -NODES[590].Fix(VELOCITY_Y); -NODES[591].Fix(VELOCITY_X); -NODES[591].Fix(VELOCITY_Y); -NODES[610].Fix(VELOCITY_X); -NODES[610].Fix(VELOCITY_Y); -NODES[611].Fix(VELOCITY_X); -NODES[611].Fix(VELOCITY_Y); -NODES[626].Fix(VELOCITY_X); -NODES[626].Fix(VELOCITY_Y); -NODES[627].Fix(VELOCITY_X); -NODES[627].Fix(VELOCITY_Y); -NODES[646].Fix(VELOCITY_X); -NODES[646].Fix(VELOCITY_Y); -NODES[647].Fix(VELOCITY_X); -NODES[647].Fix(VELOCITY_Y); -NODES[662].Fix(VELOCITY_X); -NODES[662].Fix(VELOCITY_Y); -NODES[663].Fix(VELOCITY_X); -NODES[663].Fix(VELOCITY_Y); -NODES[679].Fix(VELOCITY_X); -NODES[679].Fix(VELOCITY_Y); -NODES[680].Fix(VELOCITY_X); -NODES[680].Fix(VELOCITY_Y); -NODES[695].Fix(VELOCITY_X); -NODES[695].Fix(VELOCITY_Y); -NODES[696].Fix(VELOCITY_X); -NODES[696].Fix(VELOCITY_Y); -NODES[713].Fix(VELOCITY_X); -NODES[713].Fix(VELOCITY_Y); -NODES[714].Fix(VELOCITY_X); -NODES[714].Fix(VELOCITY_Y); -NODES[726].Fix(VELOCITY_X); -NODES[726].Fix(VELOCITY_Y); -NODES[727].Fix(VELOCITY_X); -NODES[727].Fix(VELOCITY_Y); -NODES[741].Fix(VELOCITY_X); -NODES[741].Fix(VELOCITY_Y); -NODES[742].Fix(VELOCITY_X); -NODES[742].Fix(VELOCITY_Y); -NODES[754].Fix(VELOCITY_X); -NODES[754].Fix(VELOCITY_Y); -NODES[755].Fix(VELOCITY_X); -NODES[755].Fix(VELOCITY_Y); -NODES[769].Fix(VELOCITY_X); -NODES[769].Fix(VELOCITY_Y); -NODES[770].Fix(VELOCITY_X); -NODES[770].Fix(VELOCITY_Y); -NODES[779].Fix(VELOCITY_X); -NODES[779].Fix(VELOCITY_Y); -NODES[780].Fix(VELOCITY_X); -NODES[780].Fix(VELOCITY_Y); -NODES[791].Fix(VELOCITY_X); -NODES[791].Fix(VELOCITY_Y); -NODES[792].Fix(VELOCITY_X); -NODES[792].Fix(VELOCITY_Y); -NODES[802].Fix(VELOCITY_X); -NODES[802].Fix(VELOCITY_Y); -NODES[803].Fix(VELOCITY_X); -NODES[803].Fix(VELOCITY_Y); -NODES[811].Fix(VELOCITY_X); -NODES[811].Fix(VELOCITY_Y); -NODES[812].Fix(VELOCITY_X); -NODES[812].Fix(VELOCITY_Y); -NODES[820].Fix(VELOCITY_X); -NODES[820].Fix(VELOCITY_Y); -NODES[821].Fix(VELOCITY_X); -NODES[821].Fix(VELOCITY_Y); -NODES[827].Fix(VELOCITY_X); -NODES[827].Fix(VELOCITY_Y); -NODES[828].Fix(VELOCITY_X); -NODES[828].Fix(VELOCITY_Y); -NODES[834].Fix(VELOCITY_X); -NODES[834].Fix(VELOCITY_Y); -NODES[835].Fix(VELOCITY_X); -NODES[835].Fix(VELOCITY_Y); -NODES[839].Fix(VELOCITY_X); -NODES[839].Fix(VELOCITY_Y); -NODES[840].Fix(VELOCITY_X); -NODES[840].Fix(VELOCITY_Y); -NODES[844].Fix(VELOCITY_X); -NODES[844].Fix(VELOCITY_Y); -NODES[845].Fix(VELOCITY_X); -NODES[845].Fix(VELOCITY_Y); -NODES[848].Fix(VELOCITY_X); -NODES[848].Fix(VELOCITY_Y); -NODES[849].Fix(VELOCITY_X); -NODES[849].Fix(VELOCITY_Y); -NODES[850].Fix(VELOCITY_X); -NODES[850].Fix(VELOCITY_Y); -NODES[851].Fix(VELOCITY_X); -NODES[851].Fix(VELOCITY_Y); -NODES[852].Fix(VELOCITY_X); -NODES[852].Fix(VELOCITY_Y); diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.dat b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.dat deleted file mode 100644 index cd1cd61ef19d..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.dat +++ /dev/null @@ -1 +0,0 @@ -Write comments and documentation diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.elem b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.elem deleted file mode 100644 index 6b22fec77ace..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.elem +++ /dev/null @@ -1,1406 +0,0 @@ -// Reading Elements - -ElementsGroup = fluid_group; - -ELEMENTS[1] = Fluid2D([129,114,132],0); -ELEMENTS[2] = Fluid2D([399,437,427],0); -ELEMENTS[3] = Fluid2D([821,812,807],0); -ELEMENTS[4] = Fluid2D([132,114,112],0); -ELEMENTS[5] = Fluid2D([427,437,469],0); -ELEMENTS[6] = Fluid2D([807,812,796],0); -ELEMENTS[7] = Fluid2D([469,437,472],0); -ELEMENTS[8] = Fluid2D([469,472,512],0); -ELEMENTS[9] = Fluid2D([512,472,513],0); -ELEMENTS[10] = Fluid2D([796,812,803],0); -ELEMENTS[11] = Fluid2D([555,574,513],0); -ELEMENTS[12] = Fluid2D([112,114,100],0); -ELEMENTS[13] = Fluid2D([112,100,103],0); -ELEMENTS[14] = Fluid2D([103,100,87],0); -ELEMENTS[15] = Fluid2D([103,87,89],0); -ELEMENTS[16] = Fluid2D([89,87,77],0); -ELEMENTS[17] = Fluid2D([103,89,105],0); -ELEMENTS[18] = Fluid2D([89,77,78],0); -ELEMENTS[19] = Fluid2D([105,89,90],0); -ELEMENTS[20] = Fluid2D([90,89,78],0); -ELEMENTS[21] = Fluid2D([90,78,81],0); -ELEMENTS[22] = Fluid2D([81,78,68],0); -ELEMENTS[23] = Fluid2D([68,78,67],0); -ELEMENTS[24] = Fluid2D([67,78,77],0); -ELEMENTS[25] = Fluid2D([81,68,73],0); -ELEMENTS[26] = Fluid2D([81,73,85],0); -ELEMENTS[27] = Fluid2D([85,73,75],0); -ELEMENTS[28] = Fluid2D([75,73,64],0); -ELEMENTS[29] = Fluid2D([64,73,62],0); -ELEMENTS[30] = Fluid2D([85,75,93],0); -ELEMENTS[31] = Fluid2D([73,68,62],0); -ELEMENTS[32] = Fluid2D([62,68,59],0); -ELEMENTS[33] = Fluid2D([59,68,67],0); -ELEMENTS[34] = Fluid2D([62,59,53],0); -ELEMENTS[35] = Fluid2D([62,53,55],0); -ELEMENTS[36] = Fluid2D([55,53,47],0); -ELEMENTS[37] = Fluid2D([93,75,80],0); -ELEMENTS[38] = Fluid2D([80,75,65],0); -ELEMENTS[39] = Fluid2D([65,75,64],0); -ELEMENTS[40] = Fluid2D([65,64,56],0); -ELEMENTS[41] = Fluid2D([56,64,55],0); -ELEMENTS[42] = Fluid2D([55,64,62],0); -ELEMENTS[43] = Fluid2D([55,47,48],0); -ELEMENTS[44] = Fluid2D([48,47,42],0); -ELEMENTS[45] = Fluid2D([48,42,43],0); -ELEMENTS[46] = Fluid2D([43,42,40],0); -ELEMENTS[47] = Fluid2D([43,40,39],0); -ELEMENTS[48] = Fluid2D([48,43,49],0); -ELEMENTS[49] = Fluid2D([49,43,45],0); -ELEMENTS[50] = Fluid2D([45,43,39],0); -ELEMENTS[51] = Fluid2D([48,49,56],0); -ELEMENTS[52] = Fluid2D([56,49,57],0); -ELEMENTS[53] = Fluid2D([57,49,51],0); -ELEMENTS[54] = Fluid2D([56,57,65],0); -ELEMENTS[55] = Fluid2D([65,57,71],0); -ELEMENTS[56] = Fluid2D([51,49,45],0); -ELEMENTS[57] = Fluid2D([51,41,46],0); -ELEMENTS[58] = Fluid2D([48,56,55],0); -ELEMENTS[59] = Fluid2D([71,57,63],0); -ELEMENTS[60] = Fluid2D([63,57,51],0); -ELEMENTS[61] = Fluid2D([63,51,54],0); -ELEMENTS[62] = Fluid2D([54,51,46],0); -ELEMENTS[63] = Fluid2D([796,803,786],0); -ELEMENTS[64] = Fluid2D([786,803,792],0); -ELEMENTS[65] = Fluid2D([796,786,777],0); -ELEMENTS[66] = Fluid2D([777,786,766],0); -ELEMENTS[67] = Fluid2D([766,786,773],0); -ELEMENTS[68] = Fluid2D([777,766,759],0); -ELEMENTS[69] = Fluid2D([773,786,792],0); -ELEMENTS[70] = Fluid2D([773,792,780],0); -ELEMENTS[71] = Fluid2D([773,780,761],0); -ELEMENTS[72] = Fluid2D([761,780,770],0); -ELEMENTS[73] = Fluid2D([761,770,746],0); -ELEMENTS[74] = Fluid2D([761,746,738],0); -ELEMENTS[75] = Fluid2D([738,746,722],0); -ELEMENTS[76] = Fluid2D([722,746,733],0); -ELEMENTS[77] = Fluid2D([733,746,755],0); -ELEMENTS[78] = Fluid2D([755,746,770],0); -ELEMENTS[79] = Fluid2D([759,766,744],0); -ELEMENTS[80] = Fluid2D([759,744,736],0); -ELEMENTS[81] = Fluid2D([744,766,751],0); -ELEMENTS[82] = Fluid2D([751,766,773],0); -ELEMENTS[83] = Fluid2D([751,773,761],0); -ELEMENTS[84] = Fluid2D([736,744,719],0); -ELEMENTS[85] = Fluid2D([719,744,729],0); -ELEMENTS[86] = Fluid2D([729,744,751],0); -ELEMENTS[87] = Fluid2D([729,751,738],0); -ELEMENTS[88] = Fluid2D([738,751,761],0); -ELEMENTS[89] = Fluid2D([736,719,710],0); -ELEMENTS[90] = Fluid2D([759,736,750],0); -ELEMENTS[91] = Fluid2D([750,736,728],0); -ELEMENTS[92] = Fluid2D([728,736,710],0); -ELEMENTS[93] = Fluid2D([728,710,702],0); -ELEMENTS[94] = Fluid2D([702,710,681],0); -ELEMENTS[95] = Fluid2D([681,710,690],0); -ELEMENTS[96] = Fluid2D([690,710,719],0); -ELEMENTS[97] = Fluid2D([728,702,720],0); -ELEMENTS[98] = Fluid2D([720,702,691],0); -ELEMENTS[99] = Fluid2D([728,720,745],0); -ELEMENTS[100] = Fluid2D([745,720,737],0); -ELEMENTS[101] = Fluid2D([737,720,711],0); -ELEMENTS[102] = Fluid2D([711,720,691],0); -ELEMENTS[103] = Fluid2D([711,691,685],0); -ELEMENTS[104] = Fluid2D([691,702,670],0); -ELEMENTS[105] = Fluid2D([670,702,681],0); -ELEMENTS[106] = Fluid2D([685,691,660],0); -ELEMENTS[107] = Fluid2D([685,660,654],0); -ELEMENTS[108] = Fluid2D([660,691,670],0); -ELEMENTS[109] = Fluid2D([660,670,638],0); -ELEMENTS[110] = Fluid2D([638,670,650],0); -ELEMENTS[111] = Fluid2D([650,670,681],0); -ELEMENTS[112] = Fluid2D([650,681,659],0); -ELEMENTS[113] = Fluid2D([659,681,690],0); -ELEMENTS[114] = Fluid2D([654,660,628],0); -ELEMENTS[115] = Fluid2D([654,628,620],0); -ELEMENTS[116] = Fluid2D([628,660,638],0); -ELEMENTS[117] = Fluid2D([620,628,593],0); -ELEMENTS[118] = Fluid2D([593,628,603],0); -ELEMENTS[119] = Fluid2D([603,628,638],0); -ELEMENTS[120] = Fluid2D([603,638,615],0); -ELEMENTS[121] = Fluid2D([603,615,578],0); -ELEMENTS[122] = Fluid2D([615,638,650],0); -ELEMENTS[123] = Fluid2D([578,615,587],0); -ELEMENTS[124] = Fluid2D([578,587,547],0); -ELEMENTS[125] = Fluid2D([547,587,560],0); -ELEMENTS[126] = Fluid2D([560,587,602],0); -ELEMENTS[127] = Fluid2D([587,615,625],0); -ELEMENTS[128] = Fluid2D([625,615,650],0); -ELEMENTS[129] = Fluid2D([796,777,790],0); -ELEMENTS[130] = Fluid2D([790,777,771],0); -ELEMENTS[131] = Fluid2D([796,790,807],0); -ELEMENTS[132] = Fluid2D([771,777,759],0); -ELEMENTS[133] = Fluid2D([771,759,750],0); -ELEMENTS[134] = Fluid2D([771,750,765],0); -ELEMENTS[135] = Fluid2D([765,750,745],0); -ELEMENTS[136] = Fluid2D([602,587,625],0); -ELEMENTS[137] = Fluid2D([602,625,639],0); -ELEMENTS[138] = Fluid2D([639,625,659],0); -ELEMENTS[139] = Fluid2D([745,750,728],0); -ELEMENTS[140] = Fluid2D([690,719,703],0); -ELEMENTS[141] = Fluid2D([690,703,671],0); -ELEMENTS[142] = Fluid2D([671,703,684],0); -ELEMENTS[143] = Fluid2D([671,684,652],0); -ELEMENTS[144] = Fluid2D([652,684,664],0); -ELEMENTS[145] = Fluid2D([652,664,630],0); -ELEMENTS[146] = Fluid2D([630,664,643],0); -ELEMENTS[147] = Fluid2D([684,703,712],0); -ELEMENTS[148] = Fluid2D([643,664,676],0); -ELEMENTS[149] = Fluid2D([712,703,729],0); -ELEMENTS[150] = Fluid2D([676,664,693],0); -ELEMENTS[151] = Fluid2D([693,664,684],0); -ELEMENTS[152] = Fluid2D([729,703,719],0); -ELEMENTS[153] = Fluid2D([807,790,801],0); -ELEMENTS[154] = Fluid2D([801,790,785],0); -ELEMENTS[155] = Fluid2D([801,785,798],0); -ELEMENTS[156] = Fluid2D([798,785,778],0); -ELEMENTS[157] = Fluid2D([778,785,765],0); -ELEMENTS[158] = Fluid2D([798,778,793],0); -ELEMENTS[159] = Fluid2D([793,778,775],0); -ELEMENTS[160] = Fluid2D([775,778,760],0); -ELEMENTS[161] = Fluid2D([760,778,765],0); -ELEMENTS[162] = Fluid2D([785,790,771],0); -ELEMENTS[163] = Fluid2D([785,771,765],0); -ELEMENTS[164] = Fluid2D([693,684,712],0); -ELEMENTS[165] = Fluid2D([693,712,722],0); -ELEMENTS[166] = Fluid2D([722,712,738],0); -ELEMENTS[167] = Fluid2D([693,722,707],0); -ELEMENTS[168] = Fluid2D([738,712,729],0); -ELEMENTS[169] = Fluid2D([707,722,733],0); -ELEMENTS[170] = Fluid2D([707,733,717],0); -ELEMENTS[171] = Fluid2D([717,733,742],0); -ELEMENTS[172] = Fluid2D([742,733,755],0); -ELEMENTS[173] = Fluid2D([707,717,688],0); -ELEMENTS[174] = Fluid2D([688,717,700],0); -ELEMENTS[175] = Fluid2D([707,688,676],0); -ELEMENTS[176] = Fluid2D([676,688,656],0); -ELEMENTS[177] = Fluid2D([656,688,669],0); -ELEMENTS[178] = Fluid2D([700,717,727],0); -ELEMENTS[179] = Fluid2D([727,717,742],0); -ELEMENTS[180] = Fluid2D([688,700,669],0); -ELEMENTS[181] = Fluid2D([693,707,676],0); -ELEMENTS[182] = Fluid2D([659,625,650],0); -ELEMENTS[183] = Fluid2D([711,685,705],0); -ELEMENTS[184] = Fluid2D([711,705,732],0); -ELEMENTS[185] = Fluid2D([711,732,737],0); -ELEMENTS[186] = Fluid2D([737,732,753],0); -ELEMENTS[187] = Fluid2D([753,732,748],0); -ELEMENTS[188] = Fluid2D([737,753,760],0); -ELEMENTS[189] = Fluid2D([760,753,775],0); -ELEMENTS[190] = Fluid2D([705,685,674],0); -ELEMENTS[191] = Fluid2D([748,732,723],0); -ELEMENTS[192] = Fluid2D([723,732,705],0); -ELEMENTS[193] = Fluid2D([723,705,694],0); -ELEMENTS[194] = Fluid2D([694,705,674],0); -ELEMENTS[195] = Fluid2D([694,674,667],0); -ELEMENTS[196] = Fluid2D([723,694,716],0); -ELEMENTS[197] = Fluid2D([716,694,689],0); -ELEMENTS[198] = Fluid2D([667,674,642],0); -ELEMENTS[199] = Fluid2D([667,642,634],0); -ELEMENTS[200] = Fluid2D([689,694,667],0); -ELEMENTS[201] = Fluid2D([634,642,608],0); -ELEMENTS[202] = Fluid2D([608,642,620],0); -ELEMENTS[203] = Fluid2D([634,608,597],0); -ELEMENTS[204] = Fluid2D([597,608,568],0); -ELEMENTS[205] = Fluid2D([568,608,582],0); -ELEMENTS[206] = Fluid2D([582,608,620],0); -ELEMENTS[207] = Fluid2D([620,642,654],0); -ELEMENTS[208] = Fluid2D([654,642,674],0); -ELEMENTS[209] = Fluid2D([654,674,685],0); -ELEMENTS[210] = Fluid2D([775,753,767],0); -ELEMENTS[211] = Fluid2D([775,767,788],0); -ELEMENTS[212] = Fluid2D([788,767,783],0); -ELEMENTS[213] = Fluid2D([783,767,763],0); -ELEMENTS[214] = Fluid2D([763,767,748],0); -ELEMENTS[215] = Fluid2D([763,748,740],0); -ELEMENTS[216] = Fluid2D([748,767,753],0); -ELEMENTS[217] = Fluid2D([740,748,723],0); -ELEMENTS[218] = Fluid2D([740,723,716],0); -ELEMENTS[219] = Fluid2D([740,716,734],0); -ELEMENTS[220] = Fluid2D([734,716,709],0); -ELEMENTS[221] = Fluid2D([709,716,689],0); -ELEMENTS[222] = Fluid2D([709,689,682],0); -ELEMENTS[223] = Fluid2D([734,709,730],0); -ELEMENTS[224] = Fluid2D([730,709,704],0); -ELEMENTS[225] = Fluid2D([704,709,682],0); -ELEMENTS[226] = Fluid2D([730,704,725],0); -ELEMENTS[227] = Fluid2D([725,704,697],0); -ELEMENTS[228] = Fluid2D([682,689,658],0); -ELEMENTS[229] = Fluid2D([658,689,667],0); -ELEMENTS[230] = Fluid2D([697,704,675],0); -ELEMENTS[231] = Fluid2D([675,704,682],0); -ELEMENTS[232] = Fluid2D([675,682,651],0); -ELEMENTS[233] = Fluid2D([651,682,658],0); -ELEMENTS[234] = Fluid2D([697,675,668],0); -ELEMENTS[235] = Fluid2D([651,658,624],0); -ELEMENTS[236] = Fluid2D([624,658,634],0); -ELEMENTS[237] = Fluid2D([634,658,667],0); -ELEMENTS[238] = Fluid2D([730,725,749],0); -ELEMENTS[239] = Fluid2D([749,725,743],0); -ELEMENTS[240] = Fluid2D([743,725,718],0); -ELEMENTS[241] = Fluid2D([743,718,739],0); -ELEMENTS[242] = Fluid2D([739,718,715],0); -ELEMENTS[243] = Fluid2D([718,725,697],0); -ELEMENTS[244] = Fluid2D([715,718,692],0); -ELEMENTS[245] = Fluid2D([715,692,687],0); -ELEMENTS[246] = Fluid2D([692,718,697],0); -ELEMENTS[247] = Fluid2D([687,692,661],0); -ELEMENTS[248] = Fluid2D([661,692,668],0); -ELEMENTS[249] = Fluid2D([668,675,645],0); -ELEMENTS[250] = Fluid2D([645,675,651],0); -ELEMENTS[251] = Fluid2D([692,697,668],0); -ELEMENTS[252] = Fluid2D([730,749,752],0); -ELEMENTS[253] = Fluid2D([730,752,734],0); -ELEMENTS[254] = Fluid2D([752,749,768],0); -ELEMENTS[255] = Fluid2D([768,749,764],0); -ELEMENTS[256] = Fluid2D([764,749,743],0); -ELEMENTS[257] = Fluid2D([734,752,757],0); -ELEMENTS[258] = Fluid2D([757,752,772],0); -ELEMENTS[259] = Fluid2D([772,752,768],0); -ELEMENTS[260] = Fluid2D([757,772,776],0); -ELEMENTS[261] = Fluid2D([776,772,789],0); -ELEMENTS[262] = Fluid2D([764,743,762],0); -ELEMENTS[263] = Fluid2D([762,743,739],0); -ELEMENTS[264] = Fluid2D([757,776,763],0); -ELEMENTS[265] = Fluid2D([757,763,740],0); -ELEMENTS[266] = Fluid2D([763,776,783],0); -ELEMENTS[267] = Fluid2D([783,776,794],0); -ELEMENTS[268] = Fluid2D([794,776,789],0); -ELEMENTS[269] = Fluid2D([794,789,806],0); -ELEMENTS[270] = Fluid2D([806,789,804],0); -ELEMENTS[271] = Fluid2D([804,789,787],0); -ELEMENTS[272] = Fluid2D([806,804,817],0); -ELEMENTS[273] = Fluid2D([817,804,815],0); -ELEMENTS[274] = Fluid2D([815,804,800],0); -ELEMENTS[275] = Fluid2D([787,789,772],0); -ELEMENTS[276] = Fluid2D([787,772,768],0); -ELEMENTS[277] = Fluid2D([787,768,784],0); -ELEMENTS[278] = Fluid2D([784,768,764],0); -ELEMENTS[279] = Fluid2D([800,804,787],0); -ELEMENTS[280] = Fluid2D([800,787,784],0); -ELEMENTS[281] = Fluid2D([800,784,797],0); -ELEMENTS[282] = Fluid2D([797,784,781],0); -ELEMENTS[283] = Fluid2D([781,784,764],0); -ELEMENTS[284] = Fluid2D([781,764,762],0); -ELEMENTS[285] = Fluid2D([781,762,782],0); -ELEMENTS[286] = Fluid2D([782,762,758],0); -ELEMENTS[287] = Fluid2D([782,758,774],0); -ELEMENTS[288] = Fluid2D([797,781,795],0); -ELEMENTS[289] = Fluid2D([758,762,739],0); -ELEMENTS[290] = Fluid2D([795,781,782],0); -ELEMENTS[291] = Fluid2D([795,782,802],0); -ELEMENTS[292] = Fluid2D([774,758,756],0); -ELEMENTS[293] = Fluid2D([756,758,735],0); -ELEMENTS[294] = Fluid2D([756,735,731],0); -ELEMENTS[295] = Fluid2D([774,756,779],0); -ELEMENTS[296] = Fluid2D([735,758,739],0); -ELEMENTS[297] = Fluid2D([731,735,708],0); -ELEMENTS[298] = Fluid2D([708,735,715],0); -ELEMENTS[299] = Fluid2D([735,739,715],0); -ELEMENTS[300] = Fluid2D([708,715,687],0); -ELEMENTS[301] = Fluid2D([708,687,683],0); -ELEMENTS[302] = Fluid2D([683,687,657],0); -ELEMENTS[303] = Fluid2D([657,687,661],0); -ELEMENTS[304] = Fluid2D([683,657,655],0); -ELEMENTS[305] = Fluid2D([683,655,678],0); -ELEMENTS[306] = Fluid2D([678,655,649],0); -ELEMENTS[307] = Fluid2D([649,655,621],0); -ELEMENTS[308] = Fluid2D([621,655,623],0); -ELEMENTS[309] = Fluid2D([623,655,657],0); -ELEMENTS[310] = Fluid2D([623,657,631],0); -ELEMENTS[311] = Fluid2D([623,631,596],0); -ELEMENTS[312] = Fluid2D([631,657,661],0); -ELEMENTS[313] = Fluid2D([596,631,601],0); -ELEMENTS[314] = Fluid2D([601,631,636],0); -ELEMENTS[315] = Fluid2D([636,631,661],0); -ELEMENTS[316] = Fluid2D([636,661,668],0); -ELEMENTS[317] = Fluid2D([708,683,706],0); -ELEMENTS[318] = Fluid2D([708,706,731],0); -ELEMENTS[319] = Fluid2D([706,683,678],0); -ELEMENTS[320] = Fluid2D([636,668,645],0); -ELEMENTS[321] = Fluid2D([731,706,721],0); -ELEMENTS[322] = Fluid2D([721,706,701],0); -ELEMENTS[323] = Fluid2D([701,706,678],0); -ELEMENTS[324] = Fluid2D([721,701,724],0); -ELEMENTS[325] = Fluid2D([724,701,699],0); -ELEMENTS[326] = Fluid2D([699,701,673],0); -ELEMENTS[327] = Fluid2D([673,701,678],0); -ELEMENTS[328] = Fluid2D([721,724,747],0); -ELEMENTS[329] = Fluid2D([636,645,609],0); -ELEMENTS[330] = Fluid2D([636,609,601],0); -ELEMENTS[331] = Fluid2D([609,645,619],0); -ELEMENTS[332] = Fluid2D([609,619,583],0); -ELEMENTS[333] = Fluid2D([583,619,586],0); -ELEMENTS[334] = Fluid2D([586,619,624],0); -ELEMENTS[335] = Fluid2D([619,645,651],0); -ELEMENTS[336] = Fluid2D([624,619,651],0); -ELEMENTS[337] = Fluid2D([601,609,573],0); -ELEMENTS[338] = Fluid2D([601,573,562],0); -ELEMENTS[339] = Fluid2D([562,573,531],0); -ELEMENTS[340] = Fluid2D([531,573,541],0); -ELEMENTS[341] = Fluid2D([531,541,499],0); -ELEMENTS[342] = Fluid2D([541,573,583],0); -ELEMENTS[343] = Fluid2D([499,541,507],0); -ELEMENTS[344] = Fluid2D([507,541,549],0); -ELEMENTS[345] = Fluid2D([549,541,583],0); -ELEMENTS[346] = Fluid2D([573,609,583],0); -ELEMENTS[347] = Fluid2D([800,797,810],0); -ELEMENTS[348] = Fluid2D([810,797,811],0); -ELEMENTS[349] = Fluid2D([800,810,815],0); -ELEMENTS[350] = Fluid2D([815,810,827],0); -ELEMENTS[351] = Fluid2D([507,549,519],0); -ELEMENTS[352] = Fluid2D([507,519,474],0); -ELEMENTS[353] = Fluid2D([519,549,558],0); -ELEMENTS[354] = Fluid2D([474,519,484],0); -ELEMENTS[355] = Fluid2D([474,484,443],0); -ELEMENTS[356] = Fluid2D([443,484,453],0); -ELEMENTS[357] = Fluid2D([484,519,526],0); -ELEMENTS[358] = Fluid2D([526,519,558],0); -ELEMENTS[359] = Fluid2D([453,484,495],0); -ELEMENTS[360] = Fluid2D([558,549,586],0); -ELEMENTS[361] = Fluid2D([586,549,583],0); -ELEMENTS[362] = Fluid2D([453,495,467],0); -ELEMENTS[363] = Fluid2D([453,467,424],0); -ELEMENTS[364] = Fluid2D([424,467,435],0); -ELEMENTS[365] = Fluid2D([467,495,509],0); -ELEMENTS[366] = Fluid2D([435,467,478],0); -ELEMENTS[367] = Fluid2D([478,467,509],0); -ELEMENTS[368] = Fluid2D([509,495,540],0); -ELEMENTS[369] = Fluid2D([509,540,552],0); -ELEMENTS[370] = Fluid2D([540,495,526],0); -ELEMENTS[371] = Fluid2D([526,495,484],0); -ELEMENTS[372] = Fluid2D([552,540,582],0); -ELEMENTS[373] = Fluid2D([552,582,593],0); -ELEMENTS[374] = Fluid2D([582,540,568],0); -ELEMENTS[375] = Fluid2D([568,540,526],0); -ELEMENTS[376] = Fluid2D([568,526,558],0); -ELEMENTS[377] = Fluid2D([593,582,620],0); -ELEMENTS[378] = Fluid2D([568,558,597],0); -ELEMENTS[379] = Fluid2D([597,558,586],0); -ELEMENTS[380] = Fluid2D([597,586,624],0); -ELEMENTS[381] = Fluid2D([597,624,634],0); -ELEMENTS[382] = Fluid2D([507,474,466],0); -ELEMENTS[383] = Fluid2D([507,466,499],0); -ELEMENTS[384] = Fluid2D([499,466,455],0); -ELEMENTS[385] = Fluid2D([499,455,487],0); -ELEMENTS[386] = Fluid2D([487,455,449],0); -ELEMENTS[387] = Fluid2D([455,466,425],0); -ELEMENTS[388] = Fluid2D([466,474,432],0); -ELEMENTS[389] = Fluid2D([425,466,432],0); -ELEMENTS[390] = Fluid2D([425,432,393],0); -ELEMENTS[391] = Fluid2D([393,432,402],0); -ELEMENTS[392] = Fluid2D([402,432,443],0); -ELEMENTS[393] = Fluid2D([432,474,443],0); -ELEMENTS[394] = Fluid2D([449,455,413],0); -ELEMENTS[395] = Fluid2D([413,455,425],0); -ELEMENTS[396] = Fluid2D([449,413,408],0); -ELEMENTS[397] = Fluid2D([449,408,441],0); -ELEMENTS[398] = Fluid2D([441,408,401],0); -ELEMENTS[399] = Fluid2D([408,413,373],0); -ELEMENTS[400] = Fluid2D([441,401,434],0); -ELEMENTS[401] = Fluid2D([373,413,385],0); -ELEMENTS[402] = Fluid2D([434,401,396],0); -ELEMENTS[403] = Fluid2D([385,413,425],0); -ELEMENTS[404] = Fluid2D([401,408,367],0); -ELEMENTS[405] = Fluid2D([367,408,373],0); -ELEMENTS[406] = Fluid2D([401,367,364],0); -ELEMENTS[407] = Fluid2D([401,364,396],0); -ELEMENTS[408] = Fluid2D([364,367,329],0); -ELEMENTS[409] = Fluid2D([329,367,334],0); -ELEMENTS[410] = Fluid2D([396,364,356],0); -ELEMENTS[411] = Fluid2D([356,364,322],0); -ELEMENTS[412] = Fluid2D([322,364,329],0); -ELEMENTS[413] = Fluid2D([322,329,282],0); -ELEMENTS[414] = Fluid2D([282,329,287],0); -ELEMENTS[415] = Fluid2D([322,282,277],0); -ELEMENTS[416] = Fluid2D([277,282,252],0); -ELEMENTS[417] = Fluid2D([252,282,259],0); -ELEMENTS[418] = Fluid2D([259,282,287],0); -ELEMENTS[419] = Fluid2D([259,287,262],0); -ELEMENTS[420] = Fluid2D([334,367,373],0); -ELEMENTS[421] = Fluid2D([334,373,342],0); -ELEMENTS[422] = Fluid2D([287,329,334],0); -ELEMENTS[423] = Fluid2D([287,334,298],0); -ELEMENTS[424] = Fluid2D([298,334,342],0); -ELEMENTS[425] = Fluid2D([298,342,310],0); -ELEMENTS[426] = Fluid2D([262,287,298],0); -ELEMENTS[427] = Fluid2D([342,373,385],0); -ELEMENTS[428] = Fluid2D([310,342,351],0); -ELEMENTS[429] = Fluid2D([310,351,320],0); -ELEMENTS[430] = Fluid2D([320,351,362],0); -ELEMENTS[431] = Fluid2D([362,351,393],0); -ELEMENTS[432] = Fluid2D([351,342,385],0); -ELEMENTS[433] = Fluid2D([351,385,393],0); -ELEMENTS[434] = Fluid2D([393,385,425],0); -ELEMENTS[435] = Fluid2D([262,298,268],0); -ELEMENTS[436] = Fluid2D([262,268,239],0); -ELEMENTS[437] = Fluid2D([239,268,245],0); -ELEMENTS[438] = Fluid2D([262,239,235],0); -ELEMENTS[439] = Fluid2D([235,239,213],0); -ELEMENTS[440] = Fluid2D([245,268,273],0); -ELEMENTS[441] = Fluid2D([273,268,310],0); -ELEMENTS[442] = Fluid2D([310,268,298],0); -ELEMENTS[443] = Fluid2D([213,239,216],0); -ELEMENTS[444] = Fluid2D([213,216,191],0); -ELEMENTS[445] = Fluid2D([191,216,197],0); -ELEMENTS[446] = Fluid2D([216,239,245],0); -ELEMENTS[447] = Fluid2D([213,191,188],0); -ELEMENTS[448] = Fluid2D([188,191,166],0); -ELEMENTS[449] = Fluid2D([166,191,171],0); -ELEMENTS[450] = Fluid2D([197,216,224],0); -ELEMENTS[451] = Fluid2D([224,216,245],0); -ELEMENTS[452] = Fluid2D([171,191,197],0); -ELEMENTS[453] = Fluid2D([171,197,180],0); -ELEMENTS[454] = Fluid2D([224,245,251],0); -ELEMENTS[455] = Fluid2D([224,251,233],0); -ELEMENTS[456] = Fluid2D([180,197,205],0); -ELEMENTS[457] = Fluid2D([205,197,224],0); -ELEMENTS[458] = Fluid2D([233,251,260],0); -ELEMENTS[459] = Fluid2D([260,251,283],0); -ELEMENTS[460] = Fluid2D([233,260,238],0); -ELEMENTS[461] = Fluid2D([238,260,266],0); -ELEMENTS[462] = Fluid2D([266,260,294],0); -ELEMENTS[463] = Fluid2D([294,260,283],0); -ELEMENTS[464] = Fluid2D([283,251,273],0); -ELEMENTS[465] = Fluid2D([251,245,273],0); -ELEMENTS[466] = Fluid2D([283,273,320],0); -ELEMENTS[467] = Fluid2D([320,273,310],0); -ELEMENTS[468] = Fluid2D([283,320,330],0); -ELEMENTS[469] = Fluid2D([283,330,294],0); -ELEMENTS[470] = Fluid2D([330,320,362],0); -ELEMENTS[471] = Fluid2D([330,362,371],0); -ELEMENTS[472] = Fluid2D([371,362,402],0); -ELEMENTS[473] = Fluid2D([402,362,393],0); -ELEMENTS[474] = Fluid2D([294,330,340],0); -ELEMENTS[475] = Fluid2D([340,330,371],0); -ELEMENTS[476] = Fluid2D([443,453,410],0); -ELEMENTS[477] = Fluid2D([410,453,424],0); -ELEMENTS[478] = Fluid2D([443,410,402],0); -ELEMENTS[479] = Fluid2D([402,410,371],0); -ELEMENTS[480] = Fluid2D([371,410,382],0); -ELEMENTS[481] = Fluid2D([382,410,424],0); -ELEMENTS[482] = Fluid2D([371,382,340],0); -ELEMENTS[483] = Fluid2D([382,424,394],0); -ELEMENTS[484] = Fluid2D([394,424,435],0); -ELEMENTS[485] = Fluid2D([394,435,407],0); -ELEMENTS[486] = Fluid2D([407,435,447],0); -ELEMENTS[487] = Fluid2D([447,435,478],0); -ELEMENTS[488] = Fluid2D([407,447,420],0); -ELEMENTS[489] = Fluid2D([420,447,461],0); -ELEMENTS[490] = Fluid2D([407,420,375],0); -ELEMENTS[491] = Fluid2D([461,447,490],0); -ELEMENTS[492] = Fluid2D([375,420,390],0); -ELEMENTS[493] = Fluid2D([490,447,478],0); -ELEMENTS[494] = Fluid2D([490,478,521],0); -ELEMENTS[495] = Fluid2D([521,478,509],0); -ELEMENTS[496] = Fluid2D([390,420,433],0); -ELEMENTS[497] = Fluid2D([390,433,406],0); -ELEMENTS[498] = Fluid2D([433,420,461],0); -ELEMENTS[499] = Fluid2D([433,461,476],0); -ELEMENTS[500] = Fluid2D([476,461,504],0); -ELEMENTS[501] = Fluid2D([406,433,448],0); -ELEMENTS[502] = Fluid2D([504,461,490],0); -ELEMENTS[503] = Fluid2D([504,490,536],0); -ELEMENTS[504] = Fluid2D([536,490,521],0); -ELEMENTS[505] = Fluid2D([536,521,561],0); -ELEMENTS[506] = Fluid2D([561,521,552],0); -ELEMENTS[507] = Fluid2D([552,521,509],0); -ELEMENTS[508] = Fluid2D([448,433,476],0); -ELEMENTS[509] = Fluid2D([340,382,353],0); -ELEMENTS[510] = Fluid2D([353,382,394],0); -ELEMENTS[511] = Fluid2D([353,394,366],0); -ELEMENTS[512] = Fluid2D([366,394,407],0); -ELEMENTS[513] = Fluid2D([366,407,375],0); -ELEMENTS[514] = Fluid2D([366,375,335],0); -ELEMENTS[515] = Fluid2D([335,375,349],0); -ELEMENTS[516] = Fluid2D([366,335,323],0); -ELEMENTS[517] = Fluid2D([349,375,390],0); -ELEMENTS[518] = Fluid2D([323,335,284],0); -ELEMENTS[519] = Fluid2D([284,335,302],0); -ELEMENTS[520] = Fluid2D([302,335,349],0); -ELEMENTS[521] = Fluid2D([302,349,321],0); -ELEMENTS[522] = Fluid2D([321,349,365],0); -ELEMENTS[523] = Fluid2D([302,321,275],0); -ELEMENTS[524] = Fluid2D([275,321,286],0); -ELEMENTS[525] = Fluid2D([286,321,336],0); -ELEMENTS[526] = Fluid2D([336,321,365],0); -ELEMENTS[527] = Fluid2D([336,365,377],0); -ELEMENTS[528] = Fluid2D([365,349,390],0); -ELEMENTS[529] = Fluid2D([377,365,406],0); -ELEMENTS[530] = Fluid2D([365,390,406],0); -ELEMENTS[531] = Fluid2D([377,406,422],0); -ELEMENTS[532] = Fluid2D([422,406,448],0); -ELEMENTS[533] = Fluid2D([377,422,395],0); -ELEMENTS[534] = Fluid2D([395,422,439],0); -ELEMENTS[535] = Fluid2D([439,422,464],0); -ELEMENTS[536] = Fluid2D([395,439,409],0); -ELEMENTS[537] = Fluid2D([409,439,454],0); -ELEMENTS[538] = Fluid2D([454,439,481],0); -ELEMENTS[539] = Fluid2D([481,439,464],0); -ELEMENTS[540] = Fluid2D([464,422,448],0); -ELEMENTS[541] = Fluid2D([464,448,491],0); -ELEMENTS[542] = Fluid2D([464,491,508],0); -ELEMENTS[543] = Fluid2D([508,491,538],0); -ELEMENTS[544] = Fluid2D([464,508,481],0); -ELEMENTS[545] = Fluid2D([481,508,523],0); -ELEMENTS[546] = Fluid2D([523,508,553],0); -ELEMENTS[547] = Fluid2D([523,553,566],0); -ELEMENTS[548] = Fluid2D([566,553,594],0); -ELEMENTS[549] = Fluid2D([538,491,520],0); -ELEMENTS[550] = Fluid2D([520,491,476],0); -ELEMENTS[551] = Fluid2D([553,508,538],0); -ELEMENTS[552] = Fluid2D([491,448,476],0); -ELEMENTS[553] = Fluid2D([594,553,580],0); -ELEMENTS[554] = Fluid2D([594,580,618],0); -ELEMENTS[555] = Fluid2D([594,618,630],0); -ELEMENTS[556] = Fluid2D([618,580,602],0); -ELEMENTS[557] = Fluid2D([602,580,560],0); -ELEMENTS[558] = Fluid2D([618,602,639],0); -ELEMENTS[559] = Fluid2D([618,639,652],0); -ELEMENTS[560] = Fluid2D([560,580,538],0); -ELEMENTS[561] = Fluid2D([580,553,538],0); -ELEMENTS[562] = Fluid2D([652,639,671],0); -ELEMENTS[563] = Fluid2D([671,639,659],0); -ELEMENTS[564] = Fluid2D([671,659,690],0); -ELEMENTS[565] = Fluid2D([630,618,652],0); -ELEMENTS[566] = Fluid2D([561,552,593],0); -ELEMENTS[567] = Fluid2D([775,788,793],0); -ELEMENTS[568] = Fluid2D([793,788,805],0); -ELEMENTS[569] = Fluid2D([793,805,808],0); -ELEMENTS[570] = Fluid2D([808,805,818],0); -ELEMENTS[571] = Fluid2D([808,818,822],0); -ELEMENTS[572] = Fluid2D([822,818,829],0); -ELEMENTS[573] = Fluid2D([829,818,826],0); -ELEMENTS[574] = Fluid2D([826,818,814],0); -ELEMENTS[575] = Fluid2D([814,818,805],0); -ELEMENTS[576] = Fluid2D([814,805,799],0); -ELEMENTS[577] = Fluid2D([799,805,788],0); -ELEMENTS[578] = Fluid2D([826,814,823],0); -ELEMENTS[579] = Fluid2D([823,814,809],0); -ELEMENTS[580] = Fluid2D([826,823,833],0); -ELEMENTS[581] = Fluid2D([809,814,799],0); -ELEMENTS[582] = Fluid2D([809,799,794],0); -ELEMENTS[583] = Fluid2D([809,794,806],0); -ELEMENTS[584] = Fluid2D([794,799,783],0); -ELEMENTS[585] = Fluid2D([833,823,831],0); -ELEMENTS[586] = Fluid2D([831,823,819],0); -ELEMENTS[587] = Fluid2D([819,823,809],0); -ELEMENTS[588] = Fluid2D([831,819,830],0); -ELEMENTS[589] = Fluid2D([830,819,817],0); -ELEMENTS[590] = Fluid2D([817,819,806],0); -ELEMENTS[591] = Fluid2D([806,819,809],0); -ELEMENTS[592] = Fluid2D([831,830,838],0); -ELEMENTS[593] = Fluid2D([831,838,841],0); -ELEMENTS[594] = Fluid2D([838,830,839],0); -ELEMENTS[595] = Fluid2D([841,838,844],0); -ELEMENTS[596] = Fluid2D([783,799,788],0); -ELEMENTS[597] = Fluid2D([822,829,832],0); -ELEMENTS[598] = Fluid2D([832,829,837],0); -ELEMENTS[599] = Fluid2D([837,829,836],0); -ELEMENTS[600] = Fluid2D([832,837,840],0); -ELEMENTS[601] = Fluid2D([836,829,826],0); -ELEMENTS[602] = Fluid2D([822,832,824],0); -ELEMENTS[603] = Fluid2D([822,824,813],0); -ELEMENTS[604] = Fluid2D([813,824,816],0); -ELEMENTS[605] = Fluid2D([813,816,801],0); -ELEMENTS[606] = Fluid2D([816,824,828],0); -ELEMENTS[607] = Fluid2D([824,832,835],0); -ELEMENTS[608] = Fluid2D([801,816,807],0); -ELEMENTS[609] = Fluid2D([828,824,835],0); -ELEMENTS[610] = Fluid2D([835,832,840],0); -ELEMENTS[611] = Fluid2D([807,816,821],0); -ELEMENTS[612] = Fluid2D([821,816,828],0); -ELEMENTS[613] = Fluid2D([840,837,845],0); -ELEMENTS[614] = Fluid2D([845,837,843],0); -ELEMENTS[615] = Fluid2D([843,837,836],0); -ELEMENTS[616] = Fluid2D([845,843,849],0); -ELEMENTS[617] = Fluid2D([849,843,847],0); -ELEMENTS[618] = Fluid2D([847,843,842],0); -ELEMENTS[619] = Fluid2D([849,847,851],0); -ELEMENTS[620] = Fluid2D([851,847,850],0); -ELEMENTS[621] = Fluid2D([842,843,836],0); -ELEMENTS[622] = Fluid2D([842,836,833],0); -ELEMENTS[623] = Fluid2D([833,836,826],0); -ELEMENTS[624] = Fluid2D([842,833,841],0); -ELEMENTS[625] = Fluid2D([841,833,831],0); -ELEMENTS[626] = Fluid2D([842,841,846],0); -ELEMENTS[627] = Fluid2D([842,846,847],0); -ELEMENTS[628] = Fluid2D([846,841,848],0); -ELEMENTS[629] = Fluid2D([847,846,850],0); -ELEMENTS[630] = Fluid2D([336,377,354],0); -ELEMENTS[631] = Fluid2D([336,354,307],0); -ELEMENTS[632] = Fluid2D([307,354,328],0); -ELEMENTS[633] = Fluid2D([336,307,286],0); -ELEMENTS[634] = Fluid2D([328,354,370],0); -ELEMENTS[635] = Fluid2D([307,328,278],0); -ELEMENTS[636] = Fluid2D([278,328,295],0); -ELEMENTS[637] = Fluid2D([278,295,261],0); -ELEMENTS[638] = Fluid2D([261,295,271],0); -ELEMENTS[639] = Fluid2D([271,295,319],0); -ELEMENTS[640] = Fluid2D([319,295,343],0); -ELEMENTS[641] = Fluid2D([343,295,328],0); -ELEMENTS[642] = Fluid2D([343,328,370],0); -ELEMENTS[643] = Fluid2D([370,354,395],0); -ELEMENTS[644] = Fluid2D([354,377,395],0); -ELEMENTS[645] = Fluid2D([343,370,387],0); -ELEMENTS[646] = Fluid2D([387,370,409],0); -ELEMENTS[647] = Fluid2D([343,387,363],0); -ELEMENTS[648] = Fluid2D([363,387,403],0); -ELEMENTS[649] = Fluid2D([403,387,428],0); -ELEMENTS[650] = Fluid2D([428,387,409],0); -ELEMENTS[651] = Fluid2D([409,370,395],0); -ELEMENTS[652] = Fluid2D([428,409,454],0); -ELEMENTS[653] = Fluid2D([428,454,471],0); -ELEMENTS[654] = Fluid2D([471,454,498],0); -ELEMENTS[655] = Fluid2D([498,454,481],0); -ELEMENTS[656] = Fluid2D([428,471,444],0); -ELEMENTS[657] = Fluid2D([444,471,488],0); -ELEMENTS[658] = Fluid2D([428,444,403],0); -ELEMENTS[659] = Fluid2D([488,471,517],0); -ELEMENTS[660] = Fluid2D([517,471,498],0); -ELEMENTS[661] = Fluid2D([517,498,543],0); -ELEMENTS[662] = Fluid2D([543,498,523],0); -ELEMENTS[663] = Fluid2D([543,523,566],0); -ELEMENTS[664] = Fluid2D([523,498,481],0); -ELEMENTS[665] = Fluid2D([403,444,423],0); -ELEMENTS[666] = Fluid2D([423,444,468],0); -ELEMENTS[667] = Fluid2D([468,444,488],0); -ELEMENTS[668] = Fluid2D([403,423,381],0); -ELEMENTS[669] = Fluid2D([381,423,400],0); -ELEMENTS[670] = Fluid2D([400,423,442],0); -ELEMENTS[671] = Fluid2D([442,423,468],0); -ELEMENTS[672] = Fluid2D([400,442,418],0); -ELEMENTS[673] = Fluid2D([400,418,374],0); -ELEMENTS[674] = Fluid2D([418,442,460],0); -ELEMENTS[675] = Fluid2D([374,418,397],0); -ELEMENTS[676] = Fluid2D([397,418,440],0); -ELEMENTS[677] = Fluid2D([460,442,485],0); -ELEMENTS[678] = Fluid2D([485,442,468],0); -ELEMENTS[679] = Fluid2D([440,418,460],0); -ELEMENTS[680] = Fluid2D([440,460,483],0); -ELEMENTS[681] = Fluid2D([483,460,506],0); -ELEMENTS[682] = Fluid2D([506,460,485],0); -ELEMENTS[683] = Fluid2D([506,485,529],0); -ELEMENTS[684] = Fluid2D([483,506,525],0); -ELEMENTS[685] = Fluid2D([525,506,550],0); -ELEMENTS[686] = Fluid2D([550,506,529],0); -ELEMENTS[687] = Fluid2D([550,529,576],0); -ELEMENTS[688] = Fluid2D([576,529,556],0); -ELEMENTS[689] = Fluid2D([556,529,510],0); -ELEMENTS[690] = Fluid2D([576,556,595],0); -ELEMENTS[691] = Fluid2D([595,556,579],0); -ELEMENTS[692] = Fluid2D([579,556,537],0); -ELEMENTS[693] = Fluid2D([529,485,510],0); -ELEMENTS[694] = Fluid2D([537,556,510],0); -ELEMENTS[695] = Fluid2D([510,485,468],0); -ELEMENTS[696] = Fluid2D([510,468,488],0); -ELEMENTS[697] = Fluid2D([510,488,537],0); -ELEMENTS[698] = Fluid2D([537,488,517],0); -ELEMENTS[699] = Fluid2D([537,517,559],0); -ELEMENTS[700] = Fluid2D([559,517,543],0); -ELEMENTS[701] = Fluid2D([559,543,584],0); -ELEMENTS[702] = Fluid2D([537,559,579],0); -ELEMENTS[703] = Fluid2D([579,559,599],0); -ELEMENTS[704] = Fluid2D([559,584,599],0); -ELEMENTS[705] = Fluid2D([599,584,622],0); -ELEMENTS[706] = Fluid2D([599,622,635],0); -ELEMENTS[707] = Fluid2D([622,584,606],0); -ELEMENTS[708] = Fluid2D([584,543,566],0); -ELEMENTS[709] = Fluid2D([584,566,606],0); -ELEMENTS[710] = Fluid2D([606,566,594],0); -ELEMENTS[711] = Fluid2D([606,594,630],0); -ELEMENTS[712] = Fluid2D([606,630,643],0); -ELEMENTS[713] = Fluid2D([635,622,656],0); -ELEMENTS[714] = Fluid2D([635,656,669],0); -ELEMENTS[715] = Fluid2D([656,622,643],0); -ELEMENTS[716] = Fluid2D([643,622,606],0); -ELEMENTS[717] = Fluid2D([635,669,653],0); -ELEMENTS[718] = Fluid2D([653,669,686],0); -ELEMENTS[719] = Fluid2D([686,669,700],0); -ELEMENTS[720] = Fluid2D([599,635,617],0); -ELEMENTS[721] = Fluid2D([617,635,653],0); -ELEMENTS[722] = Fluid2D([599,617,579],0); -ELEMENTS[723] = Fluid2D([579,617,595],0); -ELEMENTS[724] = Fluid2D([595,617,632],0); -ELEMENTS[725] = Fluid2D([632,617,653],0); -ELEMENTS[726] = Fluid2D([632,653,666],0); -ELEMENTS[727] = Fluid2D([666,653,686],0); -ELEMENTS[728] = Fluid2D([666,686,696],0); -ELEMENTS[729] = Fluid2D([666,696,680],0); -ELEMENTS[730] = Fluid2D([696,686,714],0); -ELEMENTS[731] = Fluid2D([595,632,614],0); -ELEMENTS[732] = Fluid2D([614,632,648],0); -ELEMENTS[733] = Fluid2D([648,632,666],0); -ELEMENTS[734] = Fluid2D([648,666,680],0); -ELEMENTS[735] = Fluid2D([648,680,663],0); -ELEMENTS[736] = Fluid2D([714,686,700],0); -ELEMENTS[737] = Fluid2D([714,700,727],0); -ELEMENTS[738] = Fluid2D([648,663,629],0); -ELEMENTS[739] = Fluid2D([629,663,647],0); -ELEMENTS[740] = Fluid2D([648,629,614],0); -ELEMENTS[741] = Fluid2D([614,629,592],0); -ELEMENTS[742] = Fluid2D([614,592,576],0); -ELEMENTS[743] = Fluid2D([576,592,550],0); -ELEMENTS[744] = Fluid2D([550,592,570],0); -ELEMENTS[745] = Fluid2D([570,592,612],0); -ELEMENTS[746] = Fluid2D([592,629,612],0); -ELEMENTS[747] = Fluid2D([612,629,647],0); -ELEMENTS[748] = Fluid2D([612,647,627],0); -ELEMENTS[749] = Fluid2D([612,627,589],0); -ELEMENTS[750] = Fluid2D([589,627,611],0); -ELEMENTS[751] = Fluid2D([612,589,570],0); -ELEMENTS[752] = Fluid2D([570,589,548],0); -ELEMENTS[753] = Fluid2D([548,589,569],0); -ELEMENTS[754] = Fluid2D([569,589,611],0); -ELEMENTS[755] = Fluid2D([569,611,591],0); -ELEMENTS[756] = Fluid2D([569,591,545],0); -ELEMENTS[757] = Fluid2D([569,545,524],0); -ELEMENTS[758] = Fluid2D([524,545,505],0); -ELEMENTS[759] = Fluid2D([524,505,477],0); -ELEMENTS[760] = Fluid2D([477,473,436],0); -ELEMENTS[761] = Fluid2D([505,545,514],0); -ELEMENTS[762] = Fluid2D([545,591,575],0); -ELEMENTS[763] = Fluid2D([545,575,514],0); -ELEMENTS[764] = Fluid2D([319,343,363],0); -ELEMENTS[765] = Fluid2D([319,363,337],0); -ELEMENTS[766] = Fluid2D([337,363,381],0); -ELEMENTS[767] = Fluid2D([319,337,285],0); -ELEMENTS[768] = Fluid2D([285,337,314],0); -ELEMENTS[769] = Fluid2D([314,337,357],0); -ELEMENTS[770] = Fluid2D([357,337,381],0); -ELEMENTS[771] = Fluid2D([357,381,400],0); -ELEMENTS[772] = Fluid2D([381,363,403],0); -ELEMENTS[773] = Fluid2D([357,400,374],0); -ELEMENTS[774] = Fluid2D([357,374,333],0); -ELEMENTS[775] = Fluid2D([357,333,314],0); -ELEMENTS[776] = Fluid2D([333,374,352],0); -ELEMENTS[777] = Fluid2D([333,352,308],0); -ELEMENTS[778] = Fluid2D([308,352,325],0); -ELEMENTS[779] = Fluid2D([352,374,397],0); -ELEMENTS[780] = Fluid2D([352,397,372],0); -ELEMENTS[781] = Fluid2D([372,397,414],0); -ELEMENTS[782] = Fluid2D([352,372,325],0); -ELEMENTS[783] = Fluid2D([414,397,440],0); -ELEMENTS[784] = Fluid2D([414,440,458],0); -ELEMENTS[785] = Fluid2D([414,458,438],0); -ELEMENTS[786] = Fluid2D([438,458,477],0); -ELEMENTS[787] = Fluid2D([477,458,502],0); -ELEMENTS[788] = Fluid2D([502,458,483],0); -ELEMENTS[789] = Fluid2D([458,440,483],0); -ELEMENTS[790] = Fluid2D([314,333,281],0); -ELEMENTS[791] = Fluid2D([281,333,308],0); -ELEMENTS[792] = Fluid2D([314,281,265],0); -ELEMENTS[793] = Fluid2D([265,281,250],0); -ELEMENTS[794] = Fluid2D([250,281,253],0); -ELEMENTS[795] = Fluid2D([281,308,253],0); -ELEMENTS[796] = Fluid2D([319,285,271],0); -ELEMENTS[797] = Fluid2D([271,285,255],0); -ELEMENTS[798] = Fluid2D([255,285,265],0); -ELEMENTS[799] = Fluid2D([271,255,240],0); -ELEMENTS[800] = Fluid2D([240,255,223],0); -ELEMENTS[801] = Fluid2D([223,255,234],0); -ELEMENTS[802] = Fluid2D([234,255,265],0); -ELEMENTS[803] = Fluid2D([234,265,250],0); -ELEMENTS[804] = Fluid2D([265,285,314],0); -ELEMENTS[805] = Fluid2D([234,229,206],0); -ELEMENTS[806] = Fluid2D([240,223,214],0); -ELEMENTS[807] = Fluid2D([214,223,196],0); -ELEMENTS[808] = Fluid2D([196,223,209],0); -ELEMENTS[809] = Fluid2D([240,214,232],0); -ELEMENTS[810] = Fluid2D([232,214,203],0); -ELEMENTS[811] = Fluid2D([203,214,189],0); -ELEMENTS[812] = Fluid2D([189,214,196],0); -ELEMENTS[813] = Fluid2D([189,196,172],0); -ELEMENTS[814] = Fluid2D([172,196,184],0); -ELEMENTS[815] = Fluid2D([209,223,234],0); -ELEMENTS[816] = Fluid2D([209,234,206],0); -ELEMENTS[817] = Fluid2D([189,172,168],0); -ELEMENTS[818] = Fluid2D([189,168,178],0); -ELEMENTS[819] = Fluid2D([168,172,149],0); -ELEMENTS[820] = Fluid2D([189,178,203],0); -ELEMENTS[821] = Fluid2D([178,168,158],0); -ELEMENTS[822] = Fluid2D([158,149,132],0); -ELEMENTS[823] = Fluid2D([203,178,193],0); -ELEMENTS[824] = Fluid2D([203,193,218],0); -ELEMENTS[825] = Fluid2D([218,193,211],0); -ELEMENTS[826] = Fluid2D([193,178,169],0); -ELEMENTS[827] = Fluid2D([203,218,232],0); -ELEMENTS[828] = Fluid2D([211,193,186],0); -ELEMENTS[829] = Fluid2D([186,193,169],0); -ELEMENTS[830] = Fluid2D([186,169,161],0); -ELEMENTS[831] = Fluid2D([161,169,147],0); -ELEMENTS[832] = Fluid2D([169,178,158],0); -ELEMENTS[833] = Fluid2D([147,169,158],0); -ELEMENTS[834] = Fluid2D([232,218,247],0); -ELEMENTS[835] = Fluid2D([247,218,237],0); -ELEMENTS[836] = Fluid2D([237,218,211],0); -ELEMENTS[837] = Fluid2D([237,211,226],0); -ELEMENTS[838] = Fluid2D([226,211,198],0); -ELEMENTS[839] = Fluid2D([198,211,186],0); -ELEMENTS[840] = Fluid2D([232,247,261],0); -ELEMENTS[841] = Fluid2D([198,186,173],0); -ELEMENTS[842] = Fluid2D([173,186,161],0); -ELEMENTS[843] = Fluid2D([261,247,278],0); -ELEMENTS[844] = Fluid2D([147,158,132],0); -ELEMENTS[845] = Fluid2D([278,247,264],0); -ELEMENTS[846] = Fluid2D([264,247,237],0); -ELEMENTS[847] = Fluid2D([278,264,307],0); -ELEMENTS[848] = Fluid2D([307,264,286],0); -ELEMENTS[849] = Fluid2D([264,237,257],0); -ELEMENTS[850] = Fluid2D([264,257,286],0); -ELEMENTS[851] = Fluid2D([257,237,226],0); -ELEMENTS[852] = Fluid2D([286,257,275],0); -ELEMENTS[853] = Fluid2D([275,257,243],0); -ELEMENTS[854] = Fluid2D([243,257,226],0); -ELEMENTS[855] = Fluid2D([275,243,263],0); -ELEMENTS[856] = Fluid2D([263,243,236],0); -ELEMENTS[857] = Fluid2D([236,243,215],0); -ELEMENTS[858] = Fluid2D([215,243,226],0); -ELEMENTS[859] = Fluid2D([263,236,256],0); -ELEMENTS[860] = Fluid2D([263,256,284],0); -ELEMENTS[861] = Fluid2D([284,256,276],0); -ELEMENTS[862] = Fluid2D([276,256,246],0); -ELEMENTS[863] = Fluid2D([246,256,227],0); -ELEMENTS[864] = Fluid2D([227,256,236],0); -ELEMENTS[865] = Fluid2D([227,236,208],0); -ELEMENTS[866] = Fluid2D([208,236,215],0); -ELEMENTS[867] = Fluid2D([227,208,199],0); -ELEMENTS[868] = Fluid2D([199,208,183],0); -ELEMENTS[869] = Fluid2D([183,208,190],0); -ELEMENTS[870] = Fluid2D([190,208,215],0); -ELEMENTS[871] = Fluid2D([190,215,198],0); -ELEMENTS[872] = Fluid2D([215,226,198],0); -ELEMENTS[873] = Fluid2D([190,198,173],0); -ELEMENTS[874] = Fluid2D([190,173,167],0); -ELEMENTS[875] = Fluid2D([190,167,183],0); -ELEMENTS[876] = Fluid2D([167,173,152],0); -ELEMENTS[877] = Fluid2D([167,152,148],0); -ELEMENTS[878] = Fluid2D([148,152,135],0); -ELEMENTS[879] = Fluid2D([135,152,141],0); -ELEMENTS[880] = Fluid2D([141,152,161],0); -ELEMENTS[881] = Fluid2D([152,173,161],0); -ELEMENTS[882] = Fluid2D([183,167,160],0); -ELEMENTS[883] = Fluid2D([160,167,148],0); -ELEMENTS[884] = Fluid2D([160,148,142],0); -ELEMENTS[885] = Fluid2D([142,148,127],0); -ELEMENTS[886] = Fluid2D([127,148,135],0); -ELEMENTS[887] = Fluid2D([127,135,117],0); -ELEMENTS[888] = Fluid2D([127,117,111],0); -ELEMENTS[889] = Fluid2D([117,135,121],0); -ELEMENTS[890] = Fluid2D([111,117,98],0); -ELEMENTS[891] = Fluid2D([98,117,105],0); -ELEMENTS[892] = Fluid2D([121,135,141],0); -ELEMENTS[893] = Fluid2D([121,141,123],0); -ELEMENTS[894] = Fluid2D([123,141,147],0); -ELEMENTS[895] = Fluid2D([183,160,175],0); -ELEMENTS[896] = Fluid2D([175,160,154],0); -ELEMENTS[897] = Fluid2D([175,154,170],0); -ELEMENTS[898] = Fluid2D([170,154,146],0); -ELEMENTS[899] = Fluid2D([146,154,134],0); -ELEMENTS[900] = Fluid2D([134,154,142],0); -ELEMENTS[901] = Fluid2D([142,154,160],0); -ELEMENTS[902] = Fluid2D([123,147,132],0); -ELEMENTS[903] = Fluid2D([147,141,161],0); -ELEMENTS[904] = Fluid2D([276,246,266],0); -ELEMENTS[905] = Fluid2D([266,246,238],0); -ELEMENTS[906] = Fluid2D([276,266,309],0); -ELEMENTS[907] = Fluid2D([276,309,323],0); -ELEMENTS[908] = Fluid2D([309,266,294],0); -ELEMENTS[909] = Fluid2D([309,294,340],0); -ELEMENTS[910] = Fluid2D([309,340,353],0); -ELEMENTS[911] = Fluid2D([309,353,323],0); -ELEMENTS[912] = Fluid2D([323,353,366],0); -ELEMENTS[913] = Fluid2D([238,246,217],0); -ELEMENTS[914] = Fluid2D([238,217,212],0); -ELEMENTS[915] = Fluid2D([212,217,192],0); -ELEMENTS[916] = Fluid2D([192,217,199],0); -ELEMENTS[917] = Fluid2D([199,217,227],0); -ELEMENTS[918] = Fluid2D([227,217,246],0); -ELEMENTS[919] = Fluid2D([238,212,233],0); -ELEMENTS[920] = Fluid2D([233,212,205],0); -ELEMENTS[921] = Fluid2D([233,205,224],0); -ELEMENTS[922] = Fluid2D([205,212,187],0); -ELEMENTS[923] = Fluid2D([187,212,192],0); -ELEMENTS[924] = Fluid2D([187,192,170],0); -ELEMENTS[925] = Fluid2D([170,192,175],0); -ELEMENTS[926] = Fluid2D([175,192,199],0); -ELEMENTS[927] = Fluid2D([175,199,183],0); -ELEMENTS[928] = Fluid2D([276,323,284],0); -ELEMENTS[929] = Fluid2D([196,209,184],0); -ELEMENTS[930] = Fluid2D([414,438,398],0); -ELEMENTS[931] = Fluid2D([699,673,672],0); -ELEMENTS[932] = Fluid2D([699,672,698],0); -ELEMENTS[933] = Fluid2D([672,673,644],0); -ELEMENTS[934] = Fluid2D([644,673,649],0); -ELEMENTS[935] = Fluid2D([698,672,677],0); -ELEMENTS[936] = Fluid2D([677,672,641],0); -ELEMENTS[937] = Fluid2D([641,672,644],0); -ELEMENTS[938] = Fluid2D([641,644,613],0); -ELEMENTS[939] = Fluid2D([613,644,616],0); -ELEMENTS[940] = Fluid2D([641,613,607],0); -ELEMENTS[941] = Fluid2D([607,613,577],0); -ELEMENTS[942] = Fluid2D([577,613,581],0); -ELEMENTS[943] = Fluid2D([581,613,616],0); -ELEMENTS[944] = Fluid2D([616,644,649],0); -ELEMENTS[945] = Fluid2D([616,649,621],0); -ELEMENTS[946] = Fluid2D([616,621,585],0); -ELEMENTS[947] = Fluid2D([585,621,588],0); -ELEMENTS[948] = Fluid2D([588,621,623],0); -ELEMENTS[949] = Fluid2D([616,585,581],0); -ELEMENTS[950] = Fluid2D([588,623,596],0); -ELEMENTS[951] = Fluid2D([588,596,557],0); -ELEMENTS[952] = Fluid2D([557,596,562],0); -ELEMENTS[953] = Fluid2D([581,585,544],0); -ELEMENTS[954] = Fluid2D([544,585,551],0); -ELEMENTS[955] = Fluid2D([544,551,511],0); -ELEMENTS[956] = Fluid2D([511,551,518],0); -ELEMENTS[957] = Fluid2D([518,551,557],0); -ELEMENTS[958] = Fluid2D([551,585,588],0); -ELEMENTS[959] = Fluid2D([551,588,557],0); -ELEMENTS[960] = Fluid2D([562,596,601],0); -ELEMENTS[961] = Fluid2D([677,641,640],0); -ELEMENTS[962] = Fluid2D([677,640,665],0); -ELEMENTS[963] = Fluid2D([640,641,607],0); -ELEMENTS[964] = Fluid2D([665,640,637],0); -ELEMENTS[965] = Fluid2D([637,640,605],0); -ELEMENTS[966] = Fluid2D([605,640,607],0); -ELEMENTS[967] = Fluid2D([605,607,572],0); -ELEMENTS[968] = Fluid2D([677,695,713],0); -ELEMENTS[969] = Fluid2D([572,607,577],0); -ELEMENTS[970] = Fluid2D([572,577,539],0); -ELEMENTS[971] = Fluid2D([572,539,532],0); -ELEMENTS[972] = Fluid2D([532,539,494],0); -ELEMENTS[973] = Fluid2D([539,577,542],0); -ELEMENTS[974] = Fluid2D([494,539,501],0); -ELEMENTS[975] = Fluid2D([501,539,542],0); -ELEMENTS[976] = Fluid2D([605,572,567],0); -ELEMENTS[977] = Fluid2D([605,567,600],0); -ELEMENTS[978] = Fluid2D([600,567,565],0); -ELEMENTS[979] = Fluid2D([565,567,530],0); -ELEMENTS[980] = Fluid2D([530,567,532],0); -ELEMENTS[981] = Fluid2D([567,572,532],0); -ELEMENTS[982] = Fluid2D([542,577,581],0); -ELEMENTS[983] = Fluid2D([542,581,544],0); -ELEMENTS[984] = Fluid2D([542,544,503],0); -ELEMENTS[985] = Fluid2D([503,544,511],0); -ELEMENTS[986] = Fluid2D([542,503,501],0); -ELEMENTS[987] = Fluid2D([501,503,465],0); -ELEMENTS[988] = Fluid2D([465,503,470],0); -ELEMENTS[989] = Fluid2D([465,470,429],0); -ELEMENTS[990] = Fluid2D([429,470,434],0); -ELEMENTS[991] = Fluid2D([470,503,511],0); -ELEMENTS[992] = Fluid2D([434,470,475],0); -ELEMENTS[993] = Fluid2D([475,470,511],0); -ELEMENTS[994] = Fluid2D([434,475,441],0); -ELEMENTS[995] = Fluid2D([441,475,482],0); -ELEMENTS[996] = Fluid2D([441,482,449],0); -ELEMENTS[997] = Fluid2D([482,475,518],0); -ELEMENTS[998] = Fluid2D([482,518,522],0); -ELEMENTS[999] = Fluid2D([522,518,557],0); -ELEMENTS[1000] = Fluid2D([449,482,487],0); -ELEMENTS[1001] = Fluid2D([487,482,522],0); -ELEMENTS[1002] = Fluid2D([487,522,531],0); -ELEMENTS[1003] = Fluid2D([487,531,499],0); -ELEMENTS[1004] = Fluid2D([531,522,562],0); -ELEMENTS[1005] = Fluid2D([562,522,557],0); -ELEMENTS[1006] = Fluid2D([665,637,679],0); -ELEMENTS[1007] = Fluid2D([699,698,726],0); -ELEMENTS[1008] = Fluid2D([649,673,678],0); -ELEMENTS[1009] = Fluid2D([494,501,459],0); -ELEMENTS[1010] = Fluid2D([494,459,456],0); -ELEMENTS[1011] = Fluid2D([456,459,421],0); -ELEMENTS[1012] = Fluid2D([456,421,417],0); -ELEMENTS[1013] = Fluid2D([456,417,452],0); -ELEMENTS[1014] = Fluid2D([452,417,412],0); -ELEMENTS[1015] = Fluid2D([412,417,378],0); -ELEMENTS[1016] = Fluid2D([459,501,465],0); -ELEMENTS[1017] = Fluid2D([421,459,426],0); -ELEMENTS[1018] = Fluid2D([426,459,465],0); -ELEMENTS[1019] = Fluid2D([378,417,383],0); -ELEMENTS[1020] = Fluid2D([383,417,421],0); -ELEMENTS[1021] = Fluid2D([383,421,386],0); -ELEMENTS[1022] = Fluid2D([386,421,426],0); -ELEMENTS[1023] = Fluid2D([378,383,344],0); -ELEMENTS[1024] = Fluid2D([386,426,389],0); -ELEMENTS[1025] = Fluid2D([389,426,429],0); -ELEMENTS[1026] = Fluid2D([344,383,346],0); -ELEMENTS[1027] = Fluid2D([346,383,386],0); -ELEMENTS[1028] = Fluid2D([346,386,350],0); -ELEMENTS[1029] = Fluid2D([350,386,389],0); -ELEMENTS[1030] = Fluid2D([350,389,356],0); -ELEMENTS[1031] = Fluid2D([426,465,429],0); -ELEMENTS[1032] = Fluid2D([356,389,396],0); -ELEMENTS[1033] = Fluid2D([396,389,429],0); -ELEMENTS[1034] = Fluid2D([396,429,434],0); -ELEMENTS[1035] = Fluid2D([346,350,311],0); -ELEMENTS[1036] = Fluid2D([311,350,316],0); -ELEMENTS[1037] = Fluid2D([346,311,305],0); -ELEMENTS[1038] = Fluid2D([305,311,270],0); -ELEMENTS[1039] = Fluid2D([270,311,272],0); -ELEMENTS[1040] = Fluid2D([316,350,356],0); -ELEMENTS[1041] = Fluid2D([311,316,272],0); -ELEMENTS[1042] = Fluid2D([272,316,277],0); -ELEMENTS[1043] = Fluid2D([316,356,322],0); -ELEMENTS[1044] = Fluid2D([277,316,322],0); -ELEMENTS[1045] = Fluid2D([272,277,249],0); -ELEMENTS[1046] = Fluid2D([249,277,252],0); -ELEMENTS[1047] = Fluid2D([272,249,244],0); -ELEMENTS[1048] = Fluid2D([244,249,221],0); -ELEMENTS[1049] = Fluid2D([221,249,225],0); -ELEMENTS[1050] = Fluid2D([225,249,252],0); -ELEMENTS[1051] = Fluid2D([272,244,270],0); -ELEMENTS[1052] = Fluid2D([270,244,241],0); -ELEMENTS[1053] = Fluid2D([270,241,267],0); -ELEMENTS[1054] = Fluid2D([267,241,242],0); -ELEMENTS[1055] = Fluid2D([242,241,220],0); -ELEMENTS[1056] = Fluid2D([220,241,219],0); -ELEMENTS[1057] = Fluid2D([219,241,244],0); -ELEMENTS[1058] = Fluid2D([219,244,221],0); -ELEMENTS[1059] = Fluid2D([219,221,194],0); -ELEMENTS[1060] = Fluid2D([194,221,201],0); -ELEMENTS[1061] = Fluid2D([219,194,195],0); -ELEMENTS[1062] = Fluid2D([195,194,176],0); -ELEMENTS[1063] = Fluid2D([201,221,225],0); -ELEMENTS[1064] = Fluid2D([176,194,177],0); -ELEMENTS[1065] = Fluid2D([176,177,153],0); -ELEMENTS[1066] = Fluid2D([153,177,157],0); -ELEMENTS[1067] = Fluid2D([157,177,181],0); -ELEMENTS[1068] = Fluid2D([181,177,201],0); -ELEMENTS[1069] = Fluid2D([177,194,201],0); -ELEMENTS[1070] = Fluid2D([225,252,231],0); -ELEMENTS[1071] = Fluid2D([231,252,259],0); -ELEMENTS[1072] = Fluid2D([225,231,204],0); -ELEMENTS[1073] = Fluid2D([204,231,210],0); -ELEMENTS[1074] = Fluid2D([210,231,235],0); -ELEMENTS[1075] = Fluid2D([225,204,201],0); -ELEMENTS[1076] = Fluid2D([201,204,181],0); -ELEMENTS[1077] = Fluid2D([235,231,259],0); -ELEMENTS[1078] = Fluid2D([235,259,262],0); -ELEMENTS[1079] = Fluid2D([456,452,493],0); -ELEMENTS[1080] = Fluid2D([493,452,489],0); -ELEMENTS[1081] = Fluid2D([493,489,530],0); -ELEMENTS[1082] = Fluid2D([456,493,494],0); -ELEMENTS[1083] = Fluid2D([494,493,532],0); -ELEMENTS[1084] = Fluid2D([532,493,530],0); -ELEMENTS[1085] = Fluid2D([489,452,451],0); -ELEMENTS[1086] = Fluid2D([451,452,412],0); -ELEMENTS[1087] = Fluid2D([451,412,411],0); -ELEMENTS[1088] = Fluid2D([411,412,376],0); -ELEMENTS[1089] = Fluid2D([376,412,378],0); -ELEMENTS[1090] = Fluid2D([376,378,341],0); -ELEMENTS[1091] = Fluid2D([341,378,344],0); -ELEMENTS[1092] = Fluid2D([451,411,450],0); -ELEMENTS[1093] = Fluid2D([450,411,419],0); -ELEMENTS[1094] = Fluid2D([419,411,384],0); -ELEMENTS[1095] = Fluid2D([384,411,376],0); -ELEMENTS[1096] = Fluid2D([530,489,527],0); -ELEMENTS[1097] = Fluid2D([530,527,565],0); -ELEMENTS[1098] = Fluid2D([565,527,563],0); -ELEMENTS[1099] = Fluid2D([565,563,604],0); -ELEMENTS[1100] = Fluid2D([604,563,598],0); -ELEMENTS[1101] = Fluid2D([598,563,564],0); -ELEMENTS[1102] = Fluid2D([564,563,528],0); -ELEMENTS[1103] = Fluid2D([528,563,527],0); -ELEMENTS[1104] = Fluid2D([527,489,486],0); -ELEMENTS[1105] = Fluid2D([486,489,451],0); -ELEMENTS[1106] = Fluid2D([527,486,528],0); -ELEMENTS[1107] = Fluid2D([528,486,492],0); -ELEMENTS[1108] = Fluid2D([492,486,450],0); -ELEMENTS[1109] = Fluid2D([341,344,301],0); -ELEMENTS[1110] = Fluid2D([301,344,305],0); -ELEMENTS[1111] = Fluid2D([305,344,346],0); -ELEMENTS[1112] = Fluid2D([450,486,451],0); -ELEMENTS[1113] = Fluid2D([492,450,457],0); -ELEMENTS[1114] = Fluid2D([457,450,419],0); -ELEMENTS[1115] = Fluid2D([492,457,500],0); -ELEMENTS[1116] = Fluid2D([492,500,535],0); -ELEMENTS[1117] = Fluid2D([492,535,528],0); -ELEMENTS[1118] = Fluid2D([535,500,546],0); -ELEMENTS[1119] = Fluid2D([535,546,571],0); -ELEMENTS[1120] = Fluid2D([571,546,590],0); -ELEMENTS[1121] = Fluid2D([528,535,564],0); -ELEMENTS[1122] = Fluid2D([564,535,571],0); -ELEMENTS[1123] = Fluid2D([564,571,610],0); -ELEMENTS[1124] = Fluid2D([457,419,427],0); -ELEMENTS[1125] = Fluid2D([457,427,469],0); -ELEMENTS[1126] = Fluid2D([546,500,512],0); -ELEMENTS[1127] = Fluid2D([546,512,574],0); -ELEMENTS[1128] = Fluid2D([500,457,469],0); -ELEMENTS[1129] = Fluid2D([500,469,512],0); -ELEMENTS[1130] = Fluid2D([802,811,795],0); -ELEMENTS[1131] = Fluid2D([60,66,69],0); -ELEMENTS[1132] = Fluid2D([60,69,61],0); -ELEMENTS[1133] = Fluid2D([60,61,52],0); -ELEMENTS[1134] = Fluid2D([69,66,79],0); -ELEMENTS[1135] = Fluid2D([52,61,54],0); -ELEMENTS[1136] = Fluid2D([79,66,76],0); -ELEMENTS[1137] = Fluid2D([79,76,91],0); -ELEMENTS[1138] = Fluid2D([79,91,94],0); -ELEMENTS[1139] = Fluid2D([79,94,82],0); -ELEMENTS[1140] = Fluid2D([91,76,88],0); -ELEMENTS[1141] = Fluid2D([91,88,104],0); -ELEMENTS[1142] = Fluid2D([104,88,101],0); -ELEMENTS[1143] = Fluid2D([104,101,118],0); -ELEMENTS[1144] = Fluid2D([118,101,115],0); -ELEMENTS[1145] = Fluid2D([118,115,131],0); -ELEMENTS[1146] = Fluid2D([131,115,130],0); -ELEMENTS[1147] = Fluid2D([61,69,72],0); -ELEMENTS[1148] = Fluid2D([61,72,63],0); -ELEMENTS[1149] = Fluid2D([72,69,82],0); -ELEMENTS[1150] = Fluid2D([82,69,79],0); -ELEMENTS[1151] = Fluid2D([72,82,84],0); -ELEMENTS[1152] = Fluid2D([72,84,74],0); -ELEMENTS[1153] = Fluid2D([84,82,95],0); -ELEMENTS[1154] = Fluid2D([95,82,94],0); -ELEMENTS[1155] = Fluid2D([95,94,108],0); -ELEMENTS[1156] = Fluid2D([108,94,106],0); -ELEMENTS[1157] = Fluid2D([74,84,86],0); -ELEMENTS[1158] = Fluid2D([86,84,97],0); -ELEMENTS[1159] = Fluid2D([97,84,95],0); -ELEMENTS[1160] = Fluid2D([95,108,109],0); -ELEMENTS[1161] = Fluid2D([106,94,91],0); -ELEMENTS[1162] = Fluid2D([106,91,104],0); -ELEMENTS[1163] = Fluid2D([109,108,125],0); -ELEMENTS[1164] = Fluid2D([125,108,122],0); -ELEMENTS[1165] = Fluid2D([109,125,128],0); -ELEMENTS[1166] = Fluid2D([128,125,143],0); -ELEMENTS[1167] = Fluid2D([143,125,139],0); -ELEMENTS[1168] = Fluid2D([122,108,106],0); -ELEMENTS[1169] = Fluid2D([139,125,122],0); -ELEMENTS[1170] = Fluid2D([97,95,109],0); -ELEMENTS[1171] = Fluid2D([97,109,116],0); -ELEMENTS[1172] = Fluid2D([116,109,128],0); -ELEMENTS[1173] = Fluid2D([116,128,137],0); -ELEMENTS[1174] = Fluid2D([137,128,150],0); -ELEMENTS[1175] = Fluid2D([150,128,143],0); -ELEMENTS[1176] = Fluid2D([150,143,166],0); -ELEMENTS[1177] = Fluid2D([97,116,102],0); -ELEMENTS[1178] = Fluid2D([97,102,86],0); -ELEMENTS[1179] = Fluid2D([86,102,92],0); -ELEMENTS[1180] = Fluid2D([86,80,71],0); -ELEMENTS[1181] = Fluid2D([102,116,120],0); -ELEMENTS[1182] = Fluid2D([102,120,107],0); -ELEMENTS[1183] = Fluid2D([120,116,137],0); -ELEMENTS[1184] = Fluid2D([120,137,140],0); -ELEMENTS[1185] = Fluid2D([140,137,156],0); -ELEMENTS[1186] = Fluid2D([156,137,150],0); -ELEMENTS[1187] = Fluid2D([107,120,126],0); -ELEMENTS[1188] = Fluid2D([107,126,110],0); -ELEMENTS[1189] = Fluid2D([126,120,140],0); -ELEMENTS[1190] = Fluid2D([126,140,146],0); -ELEMENTS[1191] = Fluid2D([146,140,163],0); -ELEMENTS[1192] = Fluid2D([110,126,134],0); -ELEMENTS[1193] = Fluid2D([134,126,146],0); -ELEMENTS[1194] = Fluid2D([139,122,138],0); -ELEMENTS[1195] = Fluid2D([139,138,159],0); -ELEMENTS[1196] = Fluid2D([138,122,119],0); -ELEMENTS[1197] = Fluid2D([119,122,106],0); -ELEMENTS[1198] = Fluid2D([159,138,157],0); -ELEMENTS[1199] = Fluid2D([139,159,162],0); -ELEMENTS[1200] = Fluid2D([162,159,182],0); -ELEMENTS[1201] = Fluid2D([182,159,181],0); -ELEMENTS[1202] = Fluid2D([139,162,143],0); -ELEMENTS[1203] = Fluid2D([119,106,104],0); -ELEMENTS[1204] = Fluid2D([143,162,166],0); -ELEMENTS[1205] = Fluid2D([166,162,188],0); -ELEMENTS[1206] = Fluid2D([119,104,118],0); -ELEMENTS[1207] = Fluid2D([119,118,136],0); -ELEMENTS[1208] = Fluid2D([136,118,131],0); -ELEMENTS[1209] = Fluid2D([136,131,153],0); -ELEMENTS[1210] = Fluid2D([119,136,138],0); -ELEMENTS[1211] = Fluid2D([138,136,157],0); -ELEMENTS[1212] = Fluid2D([72,74,63],0); -ELEMENTS[1213] = Fluid2D([210,235,213],0); -ELEMENTS[1214] = Fluid2D([210,213,188],0); -ELEMENTS[1215] = Fluid2D([210,188,182],0); -ELEMENTS[1216] = Fluid2D([182,188,162],0); -ELEMENTS[1217] = Fluid2D([232,261,240],0); -ELEMENTS[1218] = Fluid2D([240,261,271],0); -ELEMENTS[1219] = Fluid2D([737,760,745],0); -ELEMENTS[1220] = Fluid2D([745,760,765],0); -ELEMENTS[1221] = Fluid2D([695,677,665],0); -ELEMENTS[1222] = Fluid2D([798,793,808],0); -ELEMENTS[1223] = Fluid2D([798,808,813],0); -ELEMENTS[1224] = Fluid2D([813,808,822],0); -ELEMENTS[1225] = Fluid2D([798,813,801],0); -ELEMENTS[1226] = Fluid2D([384,376,345],0); -ELEMENTS[1227] = Fluid2D([345,376,341],0); -ELEMENTS[1228] = Fluid2D([345,341,306],0); -ELEMENTS[1229] = Fluid2D([384,345,355],0); -ELEMENTS[1230] = Fluid2D([355,345,315],0); -ELEMENTS[1231] = Fluid2D([384,355,388],0); -ELEMENTS[1232] = Fluid2D([388,355,361],0); -ELEMENTS[1233] = Fluid2D([388,361,399],0); -ELEMENTS[1234] = Fluid2D([306,341,301],0); -ELEMENTS[1235] = Fluid2D([306,301,269],0); -ELEMENTS[1236] = Fluid2D([355,315,324],0); -ELEMENTS[1237] = Fluid2D([355,324,361],0); -ELEMENTS[1238] = Fluid2D([269,301,267],0); -ELEMENTS[1239] = Fluid2D([269,267,242],0); -ELEMENTS[1240] = Fluid2D([306,269,274],0); -ELEMENTS[1241] = Fluid2D([306,274,315],0); -ELEMENTS[1242] = Fluid2D([315,274,279],0); -ELEMENTS[1243] = Fluid2D([315,279,324],0); -ELEMENTS[1244] = Fluid2D([274,269,248],0); -ELEMENTS[1245] = Fluid2D([248,269,242],0); -ELEMENTS[1246] = Fluid2D([274,248,254],0); -ELEMENTS[1247] = Fluid2D([274,254,279],0); -ELEMENTS[1248] = Fluid2D([248,242,222],0); -ELEMENTS[1249] = Fluid2D([222,242,220],0); -ELEMENTS[1250] = Fluid2D([248,222,230],0); -ELEMENTS[1251] = Fluid2D([248,230,254],0); -ELEMENTS[1252] = Fluid2D([267,301,305],0); -ELEMENTS[1253] = Fluid2D([267,305,270],0); -ELEMENTS[1254] = Fluid2D([222,220,202],0); -ELEMENTS[1255] = Fluid2D([222,202,207],0); -ELEMENTS[1256] = Fluid2D([222,207,230],0); -ELEMENTS[1257] = Fluid2D([202,220,195],0); -ELEMENTS[1258] = Fluid2D([195,220,219],0); -ELEMENTS[1259] = Fluid2D([202,195,179],0); -ELEMENTS[1260] = Fluid2D([179,195,176],0); -ELEMENTS[1261] = Fluid2D([179,176,155],0); -ELEMENTS[1262] = Fluid2D([155,176,153],0); -ELEMENTS[1263] = Fluid2D([155,153,131],0); -ELEMENTS[1264] = Fluid2D([179,155,165],0); -ELEMENTS[1265] = Fluid2D([179,165,185],0); -ELEMENTS[1266] = Fluid2D([202,179,185],0); -ELEMENTS[1267] = Fluid2D([202,185,207],0); -ELEMENTS[1268] = Fluid2D([306,315,345],0); -ELEMENTS[1269] = Fluid2D([384,388,419],0); -ELEMENTS[1270] = Fluid2D([419,388,427],0); -ELEMENTS[1271] = Fluid2D([604,598,646],0); -ELEMENTS[1272] = Fluid2D([127,111,124],0); -ELEMENTS[1273] = Fluid2D([127,124,142],0); -ELEMENTS[1274] = Fluid2D([142,124,134],0); -ELEMENTS[1275] = Fluid2D([134,124,110],0); -ELEMENTS[1276] = Fluid2D([110,124,111],0); -ELEMENTS[1277] = Fluid2D([850,852,851],0); -ELEMENTS[1278] = Fluid2D([153,157,136],0); -ELEMENTS[1279] = Fluid2D([325,280,308],0); -ELEMENTS[1280] = Fluid2D([593,603,561],0); -ELEMENTS[1281] = Fluid2D([561,603,578],0); -ELEMENTS[1282] = Fluid2D([561,578,536],0); -ELEMENTS[1283] = Fluid2D([536,578,547],0); -ELEMENTS[1284] = Fluid2D([536,547,504],0); -ELEMENTS[1285] = Fluid2D([504,547,520],0); -ELEMENTS[1286] = Fluid2D([520,547,560],0); -ELEMENTS[1287] = Fluid2D([520,560,538],0); -ELEMENTS[1288] = Fluid2D([504,520,476],0); -ELEMENTS[1289] = Fluid2D([511,518,475],0); -ELEMENTS[1290] = Fluid2D([81,85,98],0); -ELEMENTS[1291] = Fluid2D([643,676,656],0); -ELEMENTS[1292] = Fluid2D([626,646,598],0); -ELEMENTS[1293] = Fluid2D([129,132,149],0); -ELEMENTS[1294] = Fluid2D([129,149,144],0); -ELEMENTS[1295] = Fluid2D([144,149,172],0); -ELEMENTS[1296] = Fluid2D([168,149,158],0); -ELEMENTS[1297] = Fluid2D([74,86,71],0); -ELEMENTS[1298] = Fluid2D([834,830,825],0); -ELEMENTS[1299] = Fluid2D([180,205,187],0); -ELEMENTS[1300] = Fluid2D([180,187,163],0); -ELEMENTS[1301] = Fluid2D([163,187,170],0); -ELEMENTS[1302] = Fluid2D([180,163,156],0); -ELEMENTS[1303] = Fluid2D([156,163,140],0); -ELEMENTS[1304] = Fluid2D([146,163,170],0); -ELEMENTS[1305] = Fluid2D([473,477,505],0); -ELEMENTS[1306] = Fluid2D([754,769,747],0); -ELEMENTS[1307] = Fluid2D([747,769,756],0); -ELEMENTS[1308] = Fluid2D([754,747,724],0); -ELEMENTS[1309] = Fluid2D([721,747,731],0); -ELEMENTS[1310] = Fluid2D([39,41,45],0); -ELEMENTS[1311] = Fluid2D([550,570,525],0); -ELEMENTS[1312] = Fluid2D([525,570,548],0); -ELEMENTS[1313] = Fluid2D([525,548,502],0); -ELEMENTS[1314] = Fluid2D([525,502,483],0); -ELEMENTS[1315] = Fluid2D([502,548,524],0); -ELEMENTS[1316] = Fluid2D([524,548,569],0); -ELEMENTS[1317] = Fluid2D([502,524,477],0); -ELEMENTS[1318] = Fluid2D([85,93,99],0); -ELEMENTS[1319] = Fluid2D([99,93,110],0); -ELEMENTS[1320] = Fluid2D([85,99,98],0); -ELEMENTS[1321] = Fluid2D([206,184,209],0); -ELEMENTS[1322] = Fluid2D([614,576,595],0); -ELEMENTS[1323] = Fluid2D([90,81,98],0); -ELEMENTS[1324] = Fluid2D([90,98,105],0); -ELEMENTS[1325] = Fluid2D([590,610,571],0); -ELEMENTS[1326] = Fluid2D([512,513,574],0); -ELEMENTS[1327] = Fluid2D([820,827,810],0); -ELEMENTS[1328] = Fluid2D([797,795,811],0); -ELEMENTS[1329] = Fluid2D([554,514,575],0); -ELEMENTS[1330] = Fluid2D([726,741,724],0); -ELEMENTS[1331] = Fluid2D([40,37,39],0); -ELEMENTS[1332] = Fluid2D([756,731,747],0); -ELEMENTS[1333] = Fluid2D([65,71,80],0); -ELEMENTS[1334] = Fluid2D([80,86,92],0); -ELEMENTS[1335] = Fluid2D([263,284,302],0); -ELEMENTS[1336] = Fluid2D([263,302,275],0); -ELEMENTS[1337] = Fluid2D([600,565,604],0); -ELEMENTS[1338] = Fluid2D([600,604,633],0); -ELEMENTS[1339] = Fluid2D([633,604,646],0); -ELEMENTS[1340] = Fluid2D([600,633,637],0); -ELEMENTS[1341] = Fluid2D([600,637,605],0); -ELEMENTS[1342] = Fluid2D([637,633,679],0); -ELEMENTS[1343] = Fluid2D([253,229,250],0); -ELEMENTS[1344] = Fluid2D([662,679,633],0); -ELEMENTS[1345] = Fluid2D([844,848,841],0); -ELEMENTS[1346] = Fluid2D([130,145,155],0); -ELEMENTS[1347] = Fluid2D([155,145,165],0); -ELEMENTS[1348] = Fluid2D([360,372,414],0); -ELEMENTS[1349] = Fluid2D([46,52,54],0); -ELEMENTS[1350] = Fluid2D([156,150,171],0); -ELEMENTS[1351] = Fluid2D([779,791,774],0); -ELEMENTS[1352] = Fluid2D([438,477,436],0); -ELEMENTS[1353] = Fluid2D([740,734,757],0); -ELEMENTS[1354] = Fluid2D([111,98,99],0); -ELEMENTS[1355] = Fluid2D([111,99,110],0); -ELEMENTS[1356] = Fluid2D([164,144,172],0); -ELEMENTS[1357] = Fluid2D([830,817,825],0); -ELEMENTS[1358] = Fluid2D([825,817,815],0); -ELEMENTS[1359] = Fluid2D([825,815,827],0); -ELEMENTS[1360] = Fluid2D([830,834,839],0); -ELEMENTS[1361] = Fluid2D([112,103,123],0); -ELEMENTS[1362] = Fluid2D([574,590,546],0); -ELEMENTS[1363] = Fluid2D([131,130,155],0); -ELEMENTS[1364] = Fluid2D([93,80,92],0); -ELEMENTS[1365] = Fluid2D([724,699,726],0); -ELEMENTS[1366] = Fluid2D([107,110,93],0); -ELEMENTS[1367] = Fluid2D([811,820,810],0); -ELEMENTS[1368] = Fluid2D([166,171,150],0); -ELEMENTS[1369] = Fluid2D([713,726,698],0); -ELEMENTS[1370] = Fluid2D([181,204,182],0); -ELEMENTS[1371] = Fluid2D([157,181,159],0); -ELEMENTS[1372] = Fluid2D([280,253,308],0); -ELEMENTS[1373] = Fluid2D([646,662,633],0); -ELEMENTS[1374] = Fluid2D([71,63,74],0); -ELEMENTS[1375] = Fluid2D([399,427,388],0); -ELEMENTS[1376] = Fluid2D([92,102,107],0); -ELEMENTS[1377] = Fluid2D([92,107,93],0); -ELEMENTS[1378] = Fluid2D([839,844,838],0); -ELEMENTS[1379] = Fluid2D([436,398,438],0); -ELEMENTS[1380] = Fluid2D([769,779,756],0); -ELEMENTS[1381] = Fluid2D([41,51,45],0); -ELEMENTS[1382] = Fluid2D([117,121,105],0); -ELEMENTS[1383] = Fluid2D([105,121,123],0); -ELEMENTS[1384] = Fluid2D([184,164,172],0); -ELEMENTS[1385] = Fluid2D([610,598,564],0); -ELEMENTS[1386] = Fluid2D([103,105,123],0); -ELEMENTS[1387] = Fluid2D([782,774,791],0); -ELEMENTS[1388] = Fluid2D([827,834,825],0); -ELEMENTS[1389] = Fluid2D([514,473,505],0); -ELEMENTS[1390] = Fluid2D([741,754,724],0); -ELEMENTS[1391] = Fluid2D([204,210,182],0); -ELEMENTS[1392] = Fluid2D([414,398,360],0); -ELEMENTS[1393] = Fluid2D([229,234,250],0); -ELEMENTS[1394] = Fluid2D([679,695,665],0); -ELEMENTS[1395] = Fluid2D([132,112,123],0); -ELEMENTS[1396] = Fluid2D([63,54,61],0); -ELEMENTS[1397] = Fluid2D([171,180,156],0); -ELEMENTS[1398] = Fluid2D([848,850,846],0); -ELEMENTS[1399] = Fluid2D([360,325,372],0); -ELEMENTS[1400] = Fluid2D([791,802,782],0); -ELEMENTS[1401] = Fluid2D([598,610,626],0); -ELEMENTS[1402] = Fluid2D([698,677,713],0); diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.geo b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.geo deleted file mode 100644 index 057650810787..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.geo and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.init b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.init deleted file mode 100644 index 6b68e521efd8..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.init +++ /dev/null @@ -1,455 +0,0 @@ -// Fixing degrees of freedom in nodes - -NODES[1](IS_STRUCTURE,0) = 1.000000; -NODES[2](IS_STRUCTURE,0) = 1.000000; -NODES[3](IS_STRUCTURE,0) = 1.000000; -NODES[4](IS_STRUCTURE,0) = 1.000000; -NODES[5](IS_STRUCTURE,0) = 1.000000; -NODES[6](IS_STRUCTURE,0) = 1.000000; -NODES[7](IS_STRUCTURE,0) = 1.000000; -NODES[8](IS_STRUCTURE,0) = 1.000000; -NODES[9](IS_STRUCTURE,0) = 1.000000; -NODES[10](IS_STRUCTURE,0) = 1.000000; -NODES[11](IS_STRUCTURE,0) = 1.000000; -NODES[12](IS_STRUCTURE,0) = 1.000000; -NODES[13](IS_STRUCTURE,0) = 1.000000; -NODES[14](IS_STRUCTURE,0) = 1.000000; -NODES[15](IS_STRUCTURE,0) = 1.000000; -NODES[16](IS_STRUCTURE,0) = 1.000000; -NODES[17](IS_STRUCTURE,0) = 1.000000; -NODES[18](IS_STRUCTURE,0) = 1.000000; -NODES[19](IS_STRUCTURE,0) = 1.000000; -NODES[20](IS_STRUCTURE,0) = 1.000000; -NODES[21](IS_STRUCTURE,0) = 1.000000; -NODES[22](IS_STRUCTURE,0) = 1.000000; -NODES[23](IS_STRUCTURE,0) = 1.000000; -NODES[24](IS_STRUCTURE,0) = 1.000000; -NODES[25](IS_STRUCTURE,0) = 1.000000; -NODES[26](IS_STRUCTURE,0) = 1.000000; -NODES[27](IS_STRUCTURE,0) = 1.000000; -NODES[28](IS_STRUCTURE,0) = 1.000000; -NODES[29](IS_STRUCTURE,0) = 1.000000; -NODES[30](IS_STRUCTURE,0) = 1.000000; -NODES[31](IS_STRUCTURE,0) = 1.000000; -NODES[32](IS_STRUCTURE,0) = 1.000000; -NODES[33](IS_STRUCTURE,0) = 1.000000; -NODES[34](IS_STRUCTURE,0) = 1.000000; -NODES[35](IS_STRUCTURE,0) = 1.000000; -NODES[36](IS_STRUCTURE,0) = 1.000000; -NODES[38](IS_STRUCTURE,0) = 1.000000; -NODES[44](IS_STRUCTURE,0) = 1.000000; -NODES[50](IS_STRUCTURE,0) = 1.000000; -NODES[58](IS_STRUCTURE,0) = 1.000000; -NODES[70](IS_STRUCTURE,0) = 1.000000; -NODES[83](IS_STRUCTURE,0) = 1.000000; -NODES[96](IS_STRUCTURE,0) = 1.000000; -NODES[113](IS_STRUCTURE,0) = 1.000000; -NODES[133](IS_STRUCTURE,0) = 1.000000; -NODES[151](IS_STRUCTURE,0) = 1.000000; -NODES[174](IS_STRUCTURE,0) = 1.000000; -NODES[200](IS_STRUCTURE,0) = 1.000000; -NODES[228](IS_STRUCTURE,0) = 1.000000; -NODES[258](IS_STRUCTURE,0) = 1.000000; -NODES[288](IS_STRUCTURE,0) = 1.000000; -NODES[289](IS_STRUCTURE,0) = 1.000000; -NODES[290](IS_STRUCTURE,0) = 1.000000; -NODES[291](IS_STRUCTURE,0) = 1.000000; -NODES[292](IS_STRUCTURE,0) = 1.000000; -NODES[293](IS_STRUCTURE,0) = 1.000000; -NODES[296](IS_STRUCTURE,0) = 1.000000; -NODES[297](IS_STRUCTURE,0) = 1.000000; -NODES[299](IS_STRUCTURE,0) = 1.000000; -NODES[300](IS_STRUCTURE,0) = 1.000000; -NODES[303](IS_STRUCTURE,0) = 1.000000; -NODES[304](IS_STRUCTURE,0) = 1.000000; -NODES[312](IS_STRUCTURE,0) = 1.000000; -NODES[313](IS_STRUCTURE,0) = 1.000000; -NODES[317](IS_STRUCTURE,0) = 1.000000; -NODES[318](IS_STRUCTURE,0) = 1.000000; -NODES[326](IS_STRUCTURE,0) = 1.000000; -NODES[327](IS_STRUCTURE,0) = 1.000000; -NODES[331](IS_STRUCTURE,0) = 1.000000; -NODES[332](IS_STRUCTURE,0) = 1.000000; -NODES[338](IS_STRUCTURE,0) = 1.000000; -NODES[339](IS_STRUCTURE,0) = 1.000000; -NODES[347](IS_STRUCTURE,0) = 1.000000; -NODES[348](IS_STRUCTURE,0) = 1.000000; -NODES[358](IS_STRUCTURE,0) = 1.000000; -NODES[359](IS_STRUCTURE,0) = 1.000000; -NODES[368](IS_STRUCTURE,0) = 1.000000; -NODES[369](IS_STRUCTURE,0) = 1.000000; -NODES[379](IS_STRUCTURE,0) = 1.000000; -NODES[380](IS_STRUCTURE,0) = 1.000000; -NODES[391](IS_STRUCTURE,0) = 1.000000; -NODES[392](IS_STRUCTURE,0) = 1.000000; -NODES[404](IS_STRUCTURE,0) = 1.000000; -NODES[405](IS_STRUCTURE,0) = 1.000000; -NODES[415](IS_STRUCTURE,0) = 1.000000; -NODES[416](IS_STRUCTURE,0) = 1.000000; -NODES[430](IS_STRUCTURE,0) = 1.000000; -NODES[431](IS_STRUCTURE,0) = 1.000000; -NODES[445](IS_STRUCTURE,0) = 1.000000; -NODES[446](IS_STRUCTURE,0) = 1.000000; -NODES[462](IS_STRUCTURE,0) = 1.000000; -NODES[463](IS_STRUCTURE,0) = 1.000000; -NODES[479](IS_STRUCTURE,0) = 1.000000; -NODES[480](IS_STRUCTURE,0) = 1.000000; -NODES[496](IS_STRUCTURE,0) = 1.000000; -NODES[497](IS_STRUCTURE,0) = 1.000000; -NODES[515](IS_STRUCTURE,0) = 1.000000; -NODES[516](IS_STRUCTURE,0) = 1.000000; -NODES[533](IS_STRUCTURE,0) = 1.000000; -NODES[534](IS_STRUCTURE,0) = 1.000000; -NODES[554](IS_STRUCTURE,0) = 1.000000; -NODES[555](IS_STRUCTURE,0) = 1.000000; -NODES[574](IS_STRUCTURE,0) = 1.000000; -NODES[575](IS_STRUCTURE,0) = 1.000000; -NODES[590](IS_STRUCTURE,0) = 1.000000; -NODES[591](IS_STRUCTURE,0) = 1.000000; -NODES[610](IS_STRUCTURE,0) = 1.000000; -NODES[611](IS_STRUCTURE,0) = 1.000000; -NODES[626](IS_STRUCTURE,0) = 1.000000; -NODES[627](IS_STRUCTURE,0) = 1.000000; -NODES[646](IS_STRUCTURE,0) = 1.000000; -NODES[647](IS_STRUCTURE,0) = 1.000000; -NODES[662](IS_STRUCTURE,0) = 1.000000; -NODES[663](IS_STRUCTURE,0) = 1.000000; -NODES[679](IS_STRUCTURE,0) = 1.000000; -NODES[680](IS_STRUCTURE,0) = 1.000000; -NODES[695](IS_STRUCTURE,0) = 1.000000; -NODES[696](IS_STRUCTURE,0) = 1.000000; -NODES[713](IS_STRUCTURE,0) = 1.000000; -NODES[714](IS_STRUCTURE,0) = 1.000000; -NODES[726](IS_STRUCTURE,0) = 1.000000; -NODES[727](IS_STRUCTURE,0) = 1.000000; -NODES[741](IS_STRUCTURE,0) = 1.000000; -NODES[742](IS_STRUCTURE,0) = 1.000000; -NODES[754](IS_STRUCTURE,0) = 1.000000; -NODES[755](IS_STRUCTURE,0) = 1.000000; -NODES[769](IS_STRUCTURE,0) = 1.000000; -NODES[770](IS_STRUCTURE,0) = 1.000000; -NODES[779](IS_STRUCTURE,0) = 1.000000; -NODES[780](IS_STRUCTURE,0) = 1.000000; -NODES[791](IS_STRUCTURE,0) = 1.000000; -NODES[792](IS_STRUCTURE,0) = 1.000000; -NODES[802](IS_STRUCTURE,0) = 1.000000; -NODES[803](IS_STRUCTURE,0) = 1.000000; -NODES[811](IS_STRUCTURE,0) = 1.000000; -NODES[812](IS_STRUCTURE,0) = 1.000000; -NODES[820](IS_STRUCTURE,0) = 1.000000; -NODES[821](IS_STRUCTURE,0) = 1.000000; -NODES[827](IS_STRUCTURE,0) = 1.000000; -NODES[828](IS_STRUCTURE,0) = 1.000000; -NODES[834](IS_STRUCTURE,0) = 1.000000; -NODES[835](IS_STRUCTURE,0) = 1.000000; -NODES[839](IS_STRUCTURE,0) = 1.000000; -NODES[840](IS_STRUCTURE,0) = 1.000000; -NODES[844](IS_STRUCTURE,0) = 1.000000; -NODES[845](IS_STRUCTURE,0) = 1.000000; -NODES[848](IS_STRUCTURE,0) = 1.000000; -NODES[849](IS_STRUCTURE,0) = 1.000000; -NODES[850](IS_STRUCTURE,0) = 1.000000; -NODES[851](IS_STRUCTURE,0) = 1.000000; -NODES[852](IS_STRUCTURE,0) = 1.000000; -NODES[1](VELOCITY_X,0) = 0.000000; -NODES[1](VELOCITY_Y,0) = 0.000000; -NODES[2](VELOCITY_X,0) = 0.000000; -NODES[2](VELOCITY_Y,0) = 0.000000; -NODES[3](VELOCITY_X,0) = 0.000000; -NODES[3](VELOCITY_Y,0) = 0.000000; -NODES[4](VELOCITY_X,0) = 0.000000; -NODES[4](VELOCITY_Y,0) = 0.000000; -NODES[5](VELOCITY_X,0) = 0.000000; -NODES[5](VELOCITY_Y,0) = 0.000000; -NODES[6](VELOCITY_X,0) = 0.000000; -NODES[6](VELOCITY_Y,0) = 0.000000; -NODES[7](VELOCITY_X,0) = 0.000000; -NODES[7](VELOCITY_Y,0) = 0.000000; -NODES[8](VELOCITY_X,0) = 0.000000; -NODES[8](VELOCITY_Y,0) = 0.000000; -NODES[9](VELOCITY_X,0) = 0.000000; -NODES[9](VELOCITY_Y,0) = 0.000000; -NODES[10](VELOCITY_X,0) = 0.000000; -NODES[10](VELOCITY_Y,0) = 0.000000; -NODES[11](VELOCITY_X,0) = 0.000000; -NODES[11](VELOCITY_Y,0) = 0.000000; -NODES[12](VELOCITY_X,0) = 0.000000; -NODES[12](VELOCITY_Y,0) = 0.000000; -NODES[13](VELOCITY_X,0) = 0.000000; -NODES[13](VELOCITY_Y,0) = 0.000000; -NODES[14](VELOCITY_X,0) = 0.000000; -NODES[14](VELOCITY_Y,0) = 0.000000; -NODES[15](VELOCITY_X,0) = 0.000000; -NODES[15](VELOCITY_Y,0) = 0.000000; -NODES[16](VELOCITY_X,0) = 0.000000; -NODES[16](VELOCITY_Y,0) = 0.000000; -NODES[17](VELOCITY_X,0) = 0.000000; -NODES[17](VELOCITY_Y,0) = 0.000000; -NODES[18](VELOCITY_X,0) = 0.000000; -NODES[18](VELOCITY_Y,0) = 0.000000; -NODES[19](VELOCITY_X,0) = 0.000000; -NODES[19](VELOCITY_Y,0) = 0.000000; -NODES[20](VELOCITY_X,0) = 0.000000; -NODES[20](VELOCITY_Y,0) = 0.000000; -NODES[21](VELOCITY_X,0) = 0.000000; -NODES[21](VELOCITY_Y,0) = 0.000000; -NODES[22](VELOCITY_X,0) = 0.000000; -NODES[22](VELOCITY_Y,0) = 0.000000; -NODES[23](VELOCITY_X,0) = 0.000000; -NODES[23](VELOCITY_Y,0) = 0.000000; -NODES[24](VELOCITY_X,0) = 0.000000; -NODES[24](VELOCITY_Y,0) = 0.000000; -NODES[25](VELOCITY_X,0) = 0.000000; -NODES[25](VELOCITY_Y,0) = 0.000000; -NODES[26](VELOCITY_X,0) = 0.000000; -NODES[26](VELOCITY_Y,0) = 0.000000; -NODES[27](VELOCITY_X,0) = 0.000000; -NODES[27](VELOCITY_Y,0) = 0.000000; -NODES[28](VELOCITY_X,0) = 0.000000; -NODES[28](VELOCITY_Y,0) = 0.000000; -NODES[29](VELOCITY_X,0) = 0.000000; -NODES[29](VELOCITY_Y,0) = 0.000000; -NODES[30](VELOCITY_X,0) = 0.000000; -NODES[30](VELOCITY_Y,0) = 0.000000; -NODES[31](VELOCITY_X,0) = 0.000000; -NODES[31](VELOCITY_Y,0) = 0.000000; -NODES[32](VELOCITY_X,0) = 0.000000; -NODES[32](VELOCITY_Y,0) = 0.000000; -NODES[33](VELOCITY_X,0) = 0.000000; -NODES[33](VELOCITY_Y,0) = 0.000000; -NODES[34](VELOCITY_X,0) = 0.000000; -NODES[34](VELOCITY_Y,0) = 0.000000; -NODES[35](VELOCITY_X,0) = 0.000000; -NODES[35](VELOCITY_Y,0) = 0.000000; -NODES[36](VELOCITY_X,0) = 0.000000; -NODES[36](VELOCITY_Y,0) = 0.000000; -NODES[38](VELOCITY_X,0) = 0.000000; -NODES[38](VELOCITY_Y,0) = 0.000000; -NODES[44](VELOCITY_X,0) = 0.000000; -NODES[44](VELOCITY_Y,0) = 0.000000; -NODES[50](VELOCITY_X,0) = 0.000000; -NODES[50](VELOCITY_Y,0) = 0.000000; -NODES[58](VELOCITY_X,0) = 0.000000; -NODES[58](VELOCITY_Y,0) = 0.000000; -NODES[70](VELOCITY_X,0) = 0.000000; -NODES[70](VELOCITY_Y,0) = 0.000000; -NODES[83](VELOCITY_X,0) = 0.000000; -NODES[83](VELOCITY_Y,0) = 0.000000; -NODES[96](VELOCITY_X,0) = 0.000000; -NODES[96](VELOCITY_Y,0) = 0.000000; -NODES[113](VELOCITY_X,0) = 0.000000; -NODES[113](VELOCITY_Y,0) = 0.000000; -NODES[133](VELOCITY_X,0) = 0.000000; -NODES[133](VELOCITY_Y,0) = 0.000000; -NODES[151](VELOCITY_X,0) = 0.000000; -NODES[151](VELOCITY_Y,0) = 0.000000; -NODES[174](VELOCITY_X,0) = 0.000000; -NODES[174](VELOCITY_Y,0) = 0.000000; -NODES[200](VELOCITY_X,0) = 0.000000; -NODES[200](VELOCITY_Y,0) = 0.000000; -NODES[228](VELOCITY_X,0) = 0.000000; -NODES[228](VELOCITY_Y,0) = 0.000000; -NODES[258](VELOCITY_X,0) = 0.000000; -NODES[258](VELOCITY_Y,0) = 0.000000; -NODES[288](VELOCITY_X,0) = 0.000000; -NODES[288](VELOCITY_Y,0) = 0.000000; -NODES[289](VELOCITY_X,0) = 0.000000; -NODES[289](VELOCITY_Y,0) = 0.000000; -NODES[290](VELOCITY_X,0) = 0.000000; -NODES[290](VELOCITY_Y,0) = 0.000000; -NODES[291](VELOCITY_X,0) = 0.000000; -NODES[291](VELOCITY_Y,0) = 0.000000; -NODES[292](VELOCITY_X,0) = 0.000000; -NODES[292](VELOCITY_Y,0) = 0.000000; -NODES[293](VELOCITY_X,0) = 0.000000; -NODES[293](VELOCITY_Y,0) = 0.000000; -NODES[296](VELOCITY_X,0) = 0.000000; -NODES[296](VELOCITY_Y,0) = 0.000000; -NODES[297](VELOCITY_X,0) = 0.000000; -NODES[297](VELOCITY_Y,0) = 0.000000; -NODES[299](VELOCITY_X,0) = 0.000000; -NODES[299](VELOCITY_Y,0) = 0.000000; -NODES[300](VELOCITY_X,0) = 0.000000; -NODES[300](VELOCITY_Y,0) = 0.000000; -NODES[303](VELOCITY_X,0) = 0.000000; -NODES[303](VELOCITY_Y,0) = 0.000000; -NODES[304](VELOCITY_X,0) = 0.000000; -NODES[304](VELOCITY_Y,0) = 0.000000; -NODES[312](VELOCITY_X,0) = 0.000000; -NODES[312](VELOCITY_Y,0) = 0.000000; -NODES[313](VELOCITY_X,0) = 0.000000; -NODES[313](VELOCITY_Y,0) = 0.000000; -NODES[317](VELOCITY_X,0) = 0.000000; -NODES[317](VELOCITY_Y,0) = 0.000000; -NODES[318](VELOCITY_X,0) = 0.000000; -NODES[318](VELOCITY_Y,0) = 0.000000; -NODES[326](VELOCITY_X,0) = 0.000000; -NODES[326](VELOCITY_Y,0) = 0.000000; -NODES[327](VELOCITY_X,0) = 0.000000; -NODES[327](VELOCITY_Y,0) = 0.000000; -NODES[331](VELOCITY_X,0) = 0.000000; -NODES[331](VELOCITY_Y,0) = 0.000000; -NODES[332](VELOCITY_X,0) = 0.000000; -NODES[332](VELOCITY_Y,0) = 0.000000; -NODES[338](VELOCITY_X,0) = 0.000000; -NODES[338](VELOCITY_Y,0) = 0.000000; -NODES[339](VELOCITY_X,0) = 0.000000; -NODES[339](VELOCITY_Y,0) = 0.000000; -NODES[347](VELOCITY_X,0) = 0.000000; -NODES[347](VELOCITY_Y,0) = 0.000000; -NODES[348](VELOCITY_X,0) = 0.000000; -NODES[348](VELOCITY_Y,0) = 0.000000; -NODES[358](VELOCITY_X,0) = 0.000000; -NODES[358](VELOCITY_Y,0) = 0.000000; -NODES[359](VELOCITY_X,0) = 0.000000; -NODES[359](VELOCITY_Y,0) = 0.000000; -NODES[368](VELOCITY_X,0) = 0.000000; -NODES[368](VELOCITY_Y,0) = 0.000000; -NODES[369](VELOCITY_X,0) = 0.000000; -NODES[369](VELOCITY_Y,0) = 0.000000; -NODES[379](VELOCITY_X,0) = 0.000000; -NODES[379](VELOCITY_Y,0) = 0.000000; -NODES[380](VELOCITY_X,0) = 0.000000; -NODES[380](VELOCITY_Y,0) = 0.000000; -NODES[391](VELOCITY_X,0) = 0.000000; -NODES[391](VELOCITY_Y,0) = 0.000000; -NODES[392](VELOCITY_X,0) = 0.000000; -NODES[392](VELOCITY_Y,0) = 0.000000; -NODES[404](VELOCITY_X,0) = 0.000000; -NODES[404](VELOCITY_Y,0) = 0.000000; -NODES[405](VELOCITY_X,0) = 0.000000; -NODES[405](VELOCITY_Y,0) = 0.000000; -NODES[415](VELOCITY_X,0) = 0.000000; -NODES[415](VELOCITY_Y,0) = 0.000000; -NODES[416](VELOCITY_X,0) = 0.000000; -NODES[416](VELOCITY_Y,0) = 0.000000; -NODES[430](VELOCITY_X,0) = 0.000000; -NODES[430](VELOCITY_Y,0) = 0.000000; -NODES[431](VELOCITY_X,0) = 0.000000; -NODES[431](VELOCITY_Y,0) = 0.000000; -NODES[445](VELOCITY_X,0) = 0.000000; -NODES[445](VELOCITY_Y,0) = 0.000000; -NODES[446](VELOCITY_X,0) = 0.000000; -NODES[446](VELOCITY_Y,0) = 0.000000; -NODES[462](VELOCITY_X,0) = 0.000000; -NODES[462](VELOCITY_Y,0) = 0.000000; -NODES[463](VELOCITY_X,0) = 0.000000; -NODES[463](VELOCITY_Y,0) = 0.000000; -NODES[479](VELOCITY_X,0) = 0.000000; -NODES[479](VELOCITY_Y,0) = 0.000000; -NODES[480](VELOCITY_X,0) = 0.000000; -NODES[480](VELOCITY_Y,0) = 0.000000; -NODES[496](VELOCITY_X,0) = 0.000000; -NODES[496](VELOCITY_Y,0) = 0.000000; -NODES[497](VELOCITY_X,0) = 0.000000; -NODES[497](VELOCITY_Y,0) = 0.000000; -NODES[515](VELOCITY_X,0) = 0.000000; -NODES[515](VELOCITY_Y,0) = 0.000000; -NODES[516](VELOCITY_X,0) = 0.000000; -NODES[516](VELOCITY_Y,0) = 0.000000; -NODES[533](VELOCITY_X,0) = 0.000000; -NODES[533](VELOCITY_Y,0) = 0.000000; -NODES[534](VELOCITY_X,0) = 0.000000; -NODES[534](VELOCITY_Y,0) = 0.000000; -NODES[554](VELOCITY_X,0) = 0.000000; -NODES[554](VELOCITY_Y,0) = 0.000000; -NODES[555](VELOCITY_X,0) = 0.000000; -NODES[555](VELOCITY_Y,0) = 0.000000; -NODES[574](VELOCITY_X,0) = 0.000000; -NODES[574](VELOCITY_Y,0) = 0.000000; -NODES[575](VELOCITY_X,0) = 0.000000; -NODES[575](VELOCITY_Y,0) = 0.000000; -NODES[590](VELOCITY_X,0) = 0.000000; -NODES[590](VELOCITY_Y,0) = 0.000000; -NODES[591](VELOCITY_X,0) = 0.000000; -NODES[591](VELOCITY_Y,0) = 0.000000; -NODES[610](VELOCITY_X,0) = 0.000000; -NODES[610](VELOCITY_Y,0) = 0.000000; -NODES[611](VELOCITY_X,0) = 0.000000; -NODES[611](VELOCITY_Y,0) = 0.000000; -NODES[626](VELOCITY_X,0) = 0.000000; -NODES[626](VELOCITY_Y,0) = 0.000000; -NODES[627](VELOCITY_X,0) = 0.000000; -NODES[627](VELOCITY_Y,0) = 0.000000; -NODES[646](VELOCITY_X,0) = 0.000000; -NODES[646](VELOCITY_Y,0) = 0.000000; -NODES[647](VELOCITY_X,0) = 0.000000; -NODES[647](VELOCITY_Y,0) = 0.000000; -NODES[662](VELOCITY_X,0) = 0.000000; -NODES[662](VELOCITY_Y,0) = 0.000000; -NODES[663](VELOCITY_X,0) = 0.000000; -NODES[663](VELOCITY_Y,0) = 0.000000; -NODES[679](VELOCITY_X,0) = 0.000000; -NODES[679](VELOCITY_Y,0) = 0.000000; -NODES[680](VELOCITY_X,0) = 0.000000; -NODES[680](VELOCITY_Y,0) = 0.000000; -NODES[695](VELOCITY_X,0) = 0.000000; -NODES[695](VELOCITY_Y,0) = 0.000000; -NODES[696](VELOCITY_X,0) = 0.000000; -NODES[696](VELOCITY_Y,0) = 0.000000; -NODES[713](VELOCITY_X,0) = 0.000000; -NODES[713](VELOCITY_Y,0) = 0.000000; -NODES[714](VELOCITY_X,0) = 0.000000; -NODES[714](VELOCITY_Y,0) = 0.000000; -NODES[726](VELOCITY_X,0) = 0.000000; -NODES[726](VELOCITY_Y,0) = 0.000000; -NODES[727](VELOCITY_X,0) = 0.000000; -NODES[727](VELOCITY_Y,0) = 0.000000; -NODES[741](VELOCITY_X,0) = 0.000000; -NODES[741](VELOCITY_Y,0) = 0.000000; -NODES[742](VELOCITY_X,0) = 0.000000; -NODES[742](VELOCITY_Y,0) = 0.000000; -NODES[754](VELOCITY_X,0) = 0.000000; -NODES[754](VELOCITY_Y,0) = 0.000000; -NODES[755](VELOCITY_X,0) = 0.000000; -NODES[755](VELOCITY_Y,0) = 0.000000; -NODES[769](VELOCITY_X,0) = 0.000000; -NODES[769](VELOCITY_Y,0) = 0.000000; -NODES[770](VELOCITY_X,0) = 0.000000; -NODES[770](VELOCITY_Y,0) = 0.000000; -NODES[779](VELOCITY_X,0) = 0.000000; -NODES[779](VELOCITY_Y,0) = 0.000000; -NODES[780](VELOCITY_X,0) = 0.000000; -NODES[780](VELOCITY_Y,0) = 0.000000; -NODES[791](VELOCITY_X,0) = 0.000000; -NODES[791](VELOCITY_Y,0) = 0.000000; -NODES[792](VELOCITY_X,0) = 0.000000; -NODES[792](VELOCITY_Y,0) = 0.000000; -NODES[802](VELOCITY_X,0) = 0.000000; -NODES[802](VELOCITY_Y,0) = 0.000000; -NODES[803](VELOCITY_X,0) = 0.000000; -NODES[803](VELOCITY_Y,0) = 0.000000; -NODES[811](VELOCITY_X,0) = 0.000000; -NODES[811](VELOCITY_Y,0) = 0.000000; -NODES[812](VELOCITY_X,0) = 0.000000; -NODES[812](VELOCITY_Y,0) = 0.000000; -NODES[820](VELOCITY_X,0) = 0.000000; -NODES[820](VELOCITY_Y,0) = 0.000000; -NODES[821](VELOCITY_X,0) = 0.000000; -NODES[821](VELOCITY_Y,0) = 0.000000; -NODES[827](VELOCITY_X,0) = 0.000000; -NODES[827](VELOCITY_Y,0) = 0.000000; -NODES[828](VELOCITY_X,0) = 0.000000; -NODES[828](VELOCITY_Y,0) = 0.000000; -NODES[834](VELOCITY_X,0) = 0.000000; -NODES[834](VELOCITY_Y,0) = 0.000000; -NODES[835](VELOCITY_X,0) = 0.000000; -NODES[835](VELOCITY_Y,0) = 0.000000; -NODES[839](VELOCITY_X,0) = 0.000000; -NODES[839](VELOCITY_Y,0) = 0.000000; -NODES[840](VELOCITY_X,0) = 0.000000; -NODES[840](VELOCITY_Y,0) = 0.000000; -NODES[844](VELOCITY_X,0) = 0.000000; -NODES[844](VELOCITY_Y,0) = 0.000000; -NODES[845](VELOCITY_X,0) = 0.000000; -NODES[845](VELOCITY_Y,0) = 0.000000; -NODES[848](VELOCITY_X,0) = 0.000000; -NODES[848](VELOCITY_Y,0) = 0.000000; -NODES[849](VELOCITY_X,0) = 0.000000; -NODES[849](VELOCITY_Y,0) = 0.000000; -NODES[850](VELOCITY_X,0) = 0.000000; -NODES[850](VELOCITY_Y,0) = 0.000000; -NODES[851](VELOCITY_X,0) = 0.000000; -NODES[851](VELOCITY_Y,0) = 0.000000; -NODES[852](VELOCITY_X,0) = 0.000000; -NODES[852](VELOCITY_Y,0) = 0.000000; diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.lin b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.lin deleted file mode 100644 index d2646fd12da3..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.lin and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.mat b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.mat deleted file mode 100644 index 10484af2551b..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.mat +++ /dev/null @@ -1,12 +0,0 @@ -BOOK:Fluid_Material -NUMBER: 1 MATERIAL: Air -QUESTION: ID#CB#(Fluid) -VALUE: Fluid -STATE: HIDDEN -QUESTION: Density -VALUE: 1.2 -QUESTION: Viscosity -VALUE: 0.000017 -QUESTION: gravity -VALUE: 0 -END MATERIAL diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.msh b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.msh deleted file mode 100644 index e06760b45b86..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.msh and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.node b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.node deleted file mode 100644 index 0564b890e12d..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.node +++ /dev/null @@ -1,855 +0,0 @@ -NODES = NodesList([ -[1, 1.00000, 1.00000, 0.00000], -[2, 1.00000, 0.98000, 0.00000], -[3, 1.00000, 0.96000, 0.00000], -[4, 1.00000, 0.94000, 0.00000], -[5, 1.00000, 0.92000, 0.00000], -[6, 1.00000, 0.90000, 0.00000], -[7, 1.00000, 0.88000, 0.00000], -[8, 1.00000, 0.86000, 0.00000], -[9, 1.00000, 0.84000, 0.00000], -[10, 1.00000, 0.82000, 0.00000], -[11, 1.00000, 0.80000, 0.00000], -[12, 1.00000, 0.78000, 0.00000], -[13, 1.00000, 0.76000, 0.00000], -[14, 1.00000, 0.74000, 0.00000], -[15, 1.00000, 0.72000, 0.00000], -[16, 1.00000, 0.70000, 0.00000], -[17, 1.00000, 0.68000, 0.00000], -[18, 1.00000, 0.66000, 0.00000], -[19, 1.00000, 0.64000, 0.00000], -[20, 1.00000, 0.62000, 0.00000], -[21, 1.00000, 0.60000, 0.00000], -[22, 1.00000, 0.58000, 0.00000], -[23, 1.00000, 0.56000, 0.00000], -[24, 1.00000, 0.54000, 0.00000], -[25, 1.00000, 0.52000, 0.00000], -[26, 1.00000, 0.50000, 0.00000], -[27, 1.00000, 0.48000, 0.00000], -[28, 1.00000, 0.46000, 0.00000], -[29, 1.00000, 0.44000, 0.00000], -[30, 1.00000, 0.42000, 0.00000], -[31, 1.00000, 0.40000, 0.00000], -[32, 1.00000, 0.38000, 0.00000], -[33, 1.00000, 0.36000, 0.00000], -[34, 1.00000, 0.34000, 0.00000], -[35, 1.00000, 0.32000, 0.00000], -[36, 1.00000, 0.30000, 0.00000], -[37, 0.50000, 0.50000, 0.00000], -[38, 1.00000, 0.28000, 0.00000], -[39, 0.48000, 0.50000, 0.00000], -[40, 0.50000, 0.48000, 0.00000], -[41, 0.46000, 0.50000, 0.00000], -[42, 0.50000, 0.46000, 0.00000], -[43, 0.48211, 0.47208, 0.00000], -[44, 1.00000, 0.26000, 0.00000], -[45, 0.46675, 0.48274, 0.00000], -[46, 0.44000, 0.50000, 0.00000], -[47, 0.50000, 0.44000, 0.00000], -[48, 0.48217, 0.45124, 0.00000], -[49, 0.46461, 0.46321, 0.00000], -[50, 1.00000, 0.24000, 0.00000], -[51, 0.44704, 0.47843, 0.00000], -[52, 0.42000, 0.50000, 0.00000], -[53, 0.50000, 0.42000, 0.00000], -[54, 0.42824, 0.48516, 0.00000], -[55, 0.48217, 0.43058, 0.00000], -[56, 0.46409, 0.44159, 0.00000], -[57, 0.44551, 0.45320, 0.00000], -[58, 1.00000, 0.22000, 0.00000], -[59, 0.50000, 0.40000, 0.00000], -[60, 0.40000, 0.50000, 0.00000], -[61, 0.41000, 0.48268, 0.00000], -[62, 0.48248, 0.41016, 0.00000], -[63, 0.42415, 0.46471, 0.00000], -[64, 0.46428, 0.42051, 0.00000], -[65, 0.44581, 0.43078, 0.00000], -[66, 0.38000, 0.50000, 0.00000], -[67, 0.50000, 0.38000, 0.00000], -[68, 0.48306, 0.38985, 0.00000], -[69, 0.39000, 0.48268, 0.00000], -[70, 1.00000, 0.20000, 0.00000], -[71, 0.42736, 0.44049, 0.00000], -[72, 0.40091, 0.46498, 0.00000], -[73, 0.46536, 0.40000, 0.00000], -[74, 0.41000, 0.44804, 0.00000], -[75, 0.44577, 0.40999, 0.00000], -[76, 0.36000, 0.50000, 0.00000], -[77, 0.50000, 0.36000, 0.00000], -[78, 0.48387, 0.36991, 0.00000], -[79, 0.37000, 0.48268, 0.00000], -[80, 0.42660, 0.42053, 0.00000], -[81, 0.46663, 0.37901, 0.00000], -[82, 0.38000, 0.46536, 0.00000], -[83, 1.00000, 0.18000, 0.00000], -[84, 0.39136, 0.44793, 0.00000], -[85, 0.44804, 0.39000, 0.00000], -[86, 0.40592, 0.43051, 0.00000], -[87, 0.50000, 0.34000, 0.00000], -[88, 0.34000, 0.50000, 0.00000], -[89, 0.48363, 0.35008, 0.00000], -[90, 0.46990, 0.36055, 0.00000], -[91, 0.35000, 0.48268, 0.00000], -[92, 0.41000, 0.41340, 0.00000], -[93, 0.42455, 0.39812, 0.00000], -[94, 0.36000, 0.46536, 0.00000], -[95, 0.37000, 0.44804, 0.00000], -[96, 1.00000, 0.16000, 0.00000], -[97, 0.38134, 0.43066, 0.00000], -[98, 0.45000, 0.36373, 0.00000], -[99, 0.43072, 0.38000, 0.00000], -[100, 0.50000, 0.32000, 0.00000], -[101, 0.32000, 0.50000, 0.00000], -[102, 0.39121, 0.41335, 0.00000], -[103, 0.48268, 0.33000, 0.00000], -[104, 0.33000, 0.48268, 0.00000], -[105, 0.46536, 0.34000, 0.00000], -[106, 0.34000, 0.46536, 0.00000], -[107, 0.40000, 0.39608, 0.00000], -[108, 0.35000, 0.44804, 0.00000], -[109, 0.36000, 0.43072, 0.00000], -[110, 0.41070, 0.37684, 0.00000], -[111, 0.42697, 0.36147, 0.00000], -[112, 0.48508, 0.31160, 0.00000], -[113, 1.00000, 0.14000, 0.00000], -[114, 0.50000, 0.30000, 0.00000], -[115, 0.30000, 0.50000, 0.00000], -[116, 0.37000, 0.41340, 0.00000], -[117, 0.44034, 0.34478, 0.00000], -[118, 0.31000, 0.48268, 0.00000], -[119, 0.32000, 0.46536, 0.00000], -[120, 0.38000, 0.39608, 0.00000], -[121, 0.45000, 0.32909, 0.00000], -[122, 0.33000, 0.44804, 0.00000], -[123, 0.46473, 0.31561, 0.00000], -[124, 0.41038, 0.35819, 0.00000], -[125, 0.34000, 0.43072, 0.00000], -[126, 0.38743, 0.37924, 0.00000], -[127, 0.41973, 0.34464, 0.00000], -[128, 0.35000, 0.41340, 0.00000], -[129, 0.50000, 0.28000, 0.00000], -[130, 0.28000, 0.50000, 0.00000], -[131, 0.29000, 0.48268, 0.00000], -[132, 0.47801, 0.29241, 0.00000], -[133, 1.00000, 0.12000, 0.00000], -[134, 0.39378, 0.36188, 0.00000], -[135, 0.43000, 0.32909, 0.00000], -[136, 0.30000, 0.46536, 0.00000], -[137, 0.35818, 0.39649, 0.00000], -[138, 0.31000, 0.44804, 0.00000], -[139, 0.32000, 0.43072, 0.00000], -[140, 0.36621, 0.37961, 0.00000], -[141, 0.44000, 0.31177, 0.00000], -[142, 0.40071, 0.34521, 0.00000], -[143, 0.32810, 0.41383, 0.00000], -[144, 0.50000, 0.26000, 0.00000], -[145, 0.26000, 0.50000, 0.00000], -[146, 0.37375, 0.36287, 0.00000], -[147, 0.45205, 0.29438, 0.00000], -[148, 0.41000, 0.32909, 0.00000], -[149, 0.48268, 0.27000, 0.00000], -[150, 0.33660, 0.39686, 0.00000], -[151, 1.00000, 0.10000, 0.00000], -[152, 0.42000, 0.31177, 0.00000], -[153, 0.27409, 0.46664, 0.00000], -[154, 0.38000, 0.34641, 0.00000], -[155, 0.26000, 0.48497, 0.00000], -[156, 0.34500, 0.37990, 0.00000], -[157, 0.28535, 0.44909, 0.00000], -[158, 0.46155, 0.27529, 0.00000], -[159, 0.29598, 0.43164, 0.00000], -[160, 0.39000, 0.32909, 0.00000], -[161, 0.43000, 0.29445, 0.00000], -[162, 0.30639, 0.41423, 0.00000], -[163, 0.35279, 0.36309, 0.00000], -[164, 0.50000, 0.24000, 0.00000], -[165, 0.24000, 0.50000, 0.00000], -[166, 0.31500, 0.39722, 0.00000], -[167, 0.40000, 0.31177, 0.00000], -[168, 0.46679, 0.25792, 0.00000], -[169, 0.44000, 0.27713, 0.00000], -[170, 0.36000, 0.34641, 0.00000], -[171, 0.32333, 0.38029, 0.00000], -[172, 0.48000, 0.24249, 0.00000], -[173, 0.41000, 0.29445, 0.00000], -[174, 1.00000, 0.08000, 0.00000], -[175, 0.37000, 0.32909, 0.00000], -[176, 0.24954, 0.46720, 0.00000], -[177, 0.26000, 0.45033, 0.00000], -[178, 0.45000, 0.25981, 0.00000], -[179, 0.23527, 0.48382, 0.00000], -[180, 0.33181, 0.36332, 0.00000], -[181, 0.27201, 0.43255, 0.00000], -[182, 0.28230, 0.41516, 0.00000], -[183, 0.38000, 0.31177, 0.00000], -[184, 0.50000, 0.22000, 0.00000], -[185, 0.22000, 0.50000, 0.00000], -[186, 0.42000, 0.27713, 0.00000], -[187, 0.34000, 0.34641, 0.00000], -[188, 0.29245, 0.39781, 0.00000], -[189, 0.45973, 0.24204, 0.00000], -[190, 0.39000, 0.29445, 0.00000], -[191, 0.30180, 0.38064, 0.00000], -[192, 0.35000, 0.32909, 0.00000], -[193, 0.43000, 0.25981, 0.00000], -[194, 0.24000, 0.45033, 0.00000], -[195, 0.22790, 0.46711, 0.00000], -[196, 0.47167, 0.22431, 0.00000], -[197, 0.31000, 0.36373, 0.00000], -[198, 0.40000, 0.27713, 0.00000], -[199, 0.36000, 0.31177, 0.00000], -[200, 1.00000, 0.06000, 0.00000], -[201, 0.25000, 0.43301, 0.00000], -[202, 0.21404, 0.48358, 0.00000], -[203, 0.44000, 0.24249, 0.00000], -[204, 0.26000, 0.41569, 0.00000], -[205, 0.32000, 0.34641, 0.00000], -[206, 0.50000, 0.20000, 0.00000], -[207, 0.20000, 0.50000, 0.00000], -[208, 0.37000, 0.29445, 0.00000], -[209, 0.48210, 0.20846, 0.00000], -[210, 0.27000, 0.39837, 0.00000], -[211, 0.41000, 0.25981, 0.00000], -[212, 0.33000, 0.32909, 0.00000], -[213, 0.28000, 0.38105, 0.00000], -[214, 0.45000, 0.22517, 0.00000], -[215, 0.38000, 0.27713, 0.00000], -[216, 0.29000, 0.36373, 0.00000], -[217, 0.34000, 0.31177, 0.00000], -[218, 0.42000, 0.24249, 0.00000], -[219, 0.22000, 0.45033, 0.00000], -[220, 0.20725, 0.46701, 0.00000], -[221, 0.23000, 0.43301, 0.00000], -[222, 0.19370, 0.48352, 0.00000], -[223, 0.46209, 0.20775, 0.00000], -[224, 0.30000, 0.34641, 0.00000], -[225, 0.24000, 0.41569, 0.00000], -[226, 0.39000, 0.25981, 0.00000], -[227, 0.35000, 0.29445, 0.00000], -[228, 1.00000, 0.04000, 0.00000], -[229, 0.50000, 0.18000, 0.00000], -[230, 0.18000, 0.50000, 0.00000], -[231, 0.25000, 0.39837, 0.00000], -[232, 0.43000, 0.22517, 0.00000], -[233, 0.31000, 0.32909, 0.00000], -[234, 0.47708, 0.19025, 0.00000], -[235, 0.26000, 0.38105, 0.00000], -[236, 0.36000, 0.27713, 0.00000], -[237, 0.40000, 0.24249, 0.00000], -[238, 0.32000, 0.31177, 0.00000], -[239, 0.27000, 0.36373, 0.00000], -[240, 0.44000, 0.20785, 0.00000], -[241, 0.20000, 0.45033, 0.00000], -[242, 0.18724, 0.46702, 0.00000], -[243, 0.37000, 0.25981, 0.00000], -[244, 0.21000, 0.43301, 0.00000], -[245, 0.28000, 0.34641, 0.00000], -[246, 0.33000, 0.29445, 0.00000], -[247, 0.41000, 0.22517, 0.00000], -[248, 0.17363, 0.48351, 0.00000], -[249, 0.22000, 0.41569, 0.00000], -[250, 0.48216, 0.17198, 0.00000], -[251, 0.29000, 0.32909, 0.00000], -[252, 0.23000, 0.39837, 0.00000], -[253, 0.50000, 0.16000, 0.00000], -[254, 0.16000, 0.50000, 0.00000], -[255, 0.45170, 0.19045, 0.00000], -[256, 0.34000, 0.27713, 0.00000], -[257, 0.38000, 0.24249, 0.00000], -[258, 1.00000, 0.02000, 0.00000], -[259, 0.24000, 0.38105, 0.00000], -[260, 0.30000, 0.31177, 0.00000], -[261, 0.42000, 0.20785, 0.00000], -[262, 0.25000, 0.36373, 0.00000], -[263, 0.35000, 0.25981, 0.00000], -[264, 0.39000, 0.22517, 0.00000], -[265, 0.46210, 0.17306, 0.00000], -[266, 0.31000, 0.29445, 0.00000], -[267, 0.18000, 0.45033, 0.00000], -[268, 0.26000, 0.34641, 0.00000], -[269, 0.16724, 0.46702, 0.00000], -[270, 0.19000, 0.43301, 0.00000], -[271, 0.43000, 0.19053, 0.00000], -[272, 0.20000, 0.41569, 0.00000], -[273, 0.27000, 0.32909, 0.00000], -[274, 0.15360, 0.48351, 0.00000], -[275, 0.36000, 0.24249, 0.00000], -[276, 0.32000, 0.27713, 0.00000], -[277, 0.21000, 0.39837, 0.00000], -[278, 0.40000, 0.20785, 0.00000], -[279, 0.14000, 0.50000, 0.00000], -[280, 0.50000, 0.14000, 0.00000], -[281, 0.47167, 0.15657, 0.00000], -[282, 0.22000, 0.38105, 0.00000], -[283, 0.28000, 0.31177, 0.00000], -[284, 0.33000, 0.25981, 0.00000], -[285, 0.44000, 0.17321, 0.00000], -[286, 0.37000, 0.22517, 0.00000], -[287, 0.23000, 0.36373, 0.00000], -[288, 1.00000, 0.00000, 0.00000], -[289, 0.00000, 1.00000, 0.00000], -[290, 0.00000, 0.98000, 0.00000], -[291, 0.98000, 0.00000, 0.00000], -[292, 0.00000, 0.96000, 0.00000], -[293, 0.96000, 0.00000, 0.00000], -[294, 0.29000, 0.29445, 0.00000], -[295, 0.41000, 0.19053, 0.00000], -[296, 0.00000, 0.94000, 0.00000], -[297, 0.94000, 0.00000, 0.00000], -[298, 0.24000, 0.34641, 0.00000], -[299, 0.00000, 0.92000, 0.00000], -[300, 0.92000, 0.00000, 0.00000], -[301, 0.16000, 0.45033, 0.00000], -[302, 0.34000, 0.24249, 0.00000], -[303, 0.00000, 0.90000, 0.00000], -[304, 0.90000, 0.00000, 0.00000], -[305, 0.17000, 0.43301, 0.00000], -[306, 0.14706, 0.46698, 0.00000], -[307, 0.38000, 0.20785, 0.00000], -[308, 0.48000, 0.13856, 0.00000], -[309, 0.30000, 0.27713, 0.00000], -[310, 0.25000, 0.32909, 0.00000], -[311, 0.18000, 0.41569, 0.00000], -[312, 0.00000, 0.88000, 0.00000], -[313, 0.88000, 0.00000, 0.00000], -[314, 0.45000, 0.15588, 0.00000], -[315, 0.13364, 0.48351, 0.00000], -[316, 0.19000, 0.39837, 0.00000], -[317, 0.00000, 0.86000, 0.00000], -[318, 0.86000, 0.00000, 0.00000], -[319, 0.42000, 0.17321, 0.00000], -[320, 0.26000, 0.31177, 0.00000], -[321, 0.35000, 0.22517, 0.00000], -[322, 0.20000, 0.38105, 0.00000], -[323, 0.31000, 0.25981, 0.00000], -[324, 0.12000, 0.50000, 0.00000], -[325, 0.50000, 0.12000, 0.00000], -[326, 0.00000, 0.84000, 0.00000], -[327, 0.84000, 0.00000, 0.00000], -[328, 0.39000, 0.19053, 0.00000], -[329, 0.21000, 0.36373, 0.00000], -[330, 0.27000, 0.29445, 0.00000], -[331, 0.00000, 0.82000, 0.00000], -[332, 0.82000, 0.00000, 0.00000], -[333, 0.46000, 0.13856, 0.00000], -[334, 0.22000, 0.34641, 0.00000], -[335, 0.32000, 0.24249, 0.00000], -[336, 0.36000, 0.20785, 0.00000], -[337, 0.43000, 0.15588, 0.00000], -[338, 0.00000, 0.80000, 0.00000], -[339, 0.80000, 0.00000, 0.00000], -[340, 0.28000, 0.27713, 0.00000], -[341, 0.14000, 0.45033, 0.00000], -[342, 0.23000, 0.32909, 0.00000], -[343, 0.40000, 0.17321, 0.00000], -[344, 0.15000, 0.43301, 0.00000], -[345, 0.12708, 0.46698, 0.00000], -[346, 0.16000, 0.41569, 0.00000], -[347, 0.00000, 0.78000, 0.00000], -[348, 0.78000, 0.00000, 0.00000], -[349, 0.33000, 0.22517, 0.00000], -[350, 0.17000, 0.39837, 0.00000], -[351, 0.24000, 0.31177, 0.00000], -[352, 0.47167, 0.12104, 0.00000], -[353, 0.29000, 0.25981, 0.00000], -[354, 0.37000, 0.19053, 0.00000], -[355, 0.11358, 0.48350, 0.00000], -[356, 0.18000, 0.38105, 0.00000], -[357, 0.44000, 0.13856, 0.00000], -[358, 0.00000, 0.76000, 0.00000], -[359, 0.76000, 0.00000, 0.00000], -[360, 0.50000, 0.10000, 0.00000], -[361, 0.10000, 0.50000, 0.00000], -[362, 0.25000, 0.29445, 0.00000], -[363, 0.41000, 0.15588, 0.00000], -[364, 0.19000, 0.36373, 0.00000], -[365, 0.34000, 0.20785, 0.00000], -[366, 0.30000, 0.24249, 0.00000], -[367, 0.20000, 0.34641, 0.00000], -[368, 0.00000, 0.74000, 0.00000], -[369, 0.74000, 0.00000, 0.00000], -[370, 0.38000, 0.17321, 0.00000], -[371, 0.26000, 0.27713, 0.00000], -[372, 0.48000, 0.10392, 0.00000], -[373, 0.21000, 0.32909, 0.00000], -[374, 0.45000, 0.12124, 0.00000], -[375, 0.31000, 0.22517, 0.00000], -[376, 0.12000, 0.45033, 0.00000], -[377, 0.35000, 0.19053, 0.00000], -[378, 0.13000, 0.43301, 0.00000], -[379, 0.00000, 0.72000, 0.00000], -[380, 0.72000, 0.00000, 0.00000], -[381, 0.42000, 0.13856, 0.00000], -[382, 0.27000, 0.25981, 0.00000], -[383, 0.14000, 0.41569, 0.00000], -[384, 0.10716, 0.46700, 0.00000], -[385, 0.22000, 0.31177, 0.00000], -[386, 0.15000, 0.39837, 0.00000], -[387, 0.39000, 0.15588, 0.00000], -[388, 0.09361, 0.48351, 0.00000], -[389, 0.16000, 0.38105, 0.00000], -[390, 0.32000, 0.20785, 0.00000], -[391, 0.00000, 0.70000, 0.00000], -[392, 0.70000, 0.00000, 0.00000], -[393, 0.23000, 0.29445, 0.00000], -[394, 0.28000, 0.24249, 0.00000], -[395, 0.36000, 0.17321, 0.00000], -[396, 0.17000, 0.36373, 0.00000], -[397, 0.46000, 0.10392, 0.00000], -[398, 0.50000, 0.08000, 0.00000], -[399, 0.08000, 0.50000, 0.00000], -[400, 0.43000, 0.12124, 0.00000], -[401, 0.18000, 0.34641, 0.00000], -[402, 0.24000, 0.27713, 0.00000], -[403, 0.40000, 0.13856, 0.00000], -[404, 0.00000, 0.68000, 0.00000], -[405, 0.68000, 0.00000, 0.00000], -[406, 0.33000, 0.19053, 0.00000], -[407, 0.29000, 0.22517, 0.00000], -[408, 0.19000, 0.32909, 0.00000], -[409, 0.37000, 0.15588, 0.00000], -[410, 0.25000, 0.25981, 0.00000], -[411, 0.10000, 0.45033, 0.00000], -[412, 0.11000, 0.43301, 0.00000], -[413, 0.20000, 0.31177, 0.00000], -[414, 0.47167, 0.08550, 0.00000], -[415, 0.00000, 0.66000, 0.00000], -[416, 0.66000, 0.00000, 0.00000], -[417, 0.12000, 0.41569, 0.00000], -[418, 0.44000, 0.10392, 0.00000], -[419, 0.08721, 0.46701, 0.00000], -[420, 0.30000, 0.20785, 0.00000], -[421, 0.13000, 0.39837, 0.00000], -[422, 0.34000, 0.17321, 0.00000], -[423, 0.41000, 0.12124, 0.00000], -[424, 0.26000, 0.24249, 0.00000], -[425, 0.21000, 0.29445, 0.00000], -[426, 0.14000, 0.38105, 0.00000], -[427, 0.07334, 0.48344, 0.00000], -[428, 0.38000, 0.13856, 0.00000], -[429, 0.15000, 0.36373, 0.00000], -[430, 0.00000, 0.64000, 0.00000], -[431, 0.64000, 0.00000, 0.00000], -[432, 0.22000, 0.27713, 0.00000], -[433, 0.31000, 0.19053, 0.00000], -[434, 0.16000, 0.34641, 0.00000], -[435, 0.27000, 0.22517, 0.00000], -[436, 0.50000, 0.06000, 0.00000], -[437, 0.06000, 0.50000, 0.00000], -[438, 0.48207, 0.06915, 0.00000], -[439, 0.35000, 0.15588, 0.00000], -[440, 0.45000, 0.08660, 0.00000], -[441, 0.17000, 0.32909, 0.00000], -[442, 0.42000, 0.10392, 0.00000], -[443, 0.23000, 0.25981, 0.00000], -[444, 0.39000, 0.12124, 0.00000], -[445, 0.00000, 0.62000, 0.00000], -[446, 0.62000, 0.00000, 0.00000], -[447, 0.28000, 0.20785, 0.00000], -[448, 0.32000, 0.17321, 0.00000], -[449, 0.18000, 0.31177, 0.00000], -[450, 0.08000, 0.45033, 0.00000], -[451, 0.09000, 0.43301, 0.00000], -[452, 0.10000, 0.41569, 0.00000], -[453, 0.24000, 0.24249, 0.00000], -[454, 0.36000, 0.13856, 0.00000], -[455, 0.19000, 0.29445, 0.00000], -[456, 0.11000, 0.39837, 0.00000], -[457, 0.06623, 0.46676, 0.00000], -[458, 0.46199, 0.06894, 0.00000], -[459, 0.12000, 0.38105, 0.00000], -[460, 0.43000, 0.08660, 0.00000], -[461, 0.29000, 0.19053, 0.00000], -[462, 0.00000, 0.60000, 0.00000], -[463, 0.60000, 0.00000, 0.00000], -[464, 0.33000, 0.15588, 0.00000], -[465, 0.13000, 0.36373, 0.00000], -[466, 0.20000, 0.27713, 0.00000], -[467, 0.25000, 0.22517, 0.00000], -[468, 0.40000, 0.10392, 0.00000], -[469, 0.05275, 0.48328, 0.00000], -[470, 0.14000, 0.34641, 0.00000], -[471, 0.37000, 0.12124, 0.00000], -[472, 0.04000, 0.50000, 0.00000], -[473, 0.50000, 0.04000, 0.00000], -[474, 0.21000, 0.25981, 0.00000], -[475, 0.15000, 0.32909, 0.00000], -[476, 0.30000, 0.17321, 0.00000], -[477, 0.47673, 0.05131, 0.00000], -[478, 0.26000, 0.20785, 0.00000], -[479, 0.00000, 0.58000, 0.00000], -[480, 0.58000, 0.00000, 0.00000], -[481, 0.34000, 0.13856, 0.00000], -[482, 0.16000, 0.31177, 0.00000], -[483, 0.44000, 0.06928, 0.00000], -[484, 0.22000, 0.24249, 0.00000], -[485, 0.41000, 0.08660, 0.00000], -[486, 0.07000, 0.43301, 0.00000], -[487, 0.17000, 0.29445, 0.00000], -[488, 0.38000, 0.10392, 0.00000], -[489, 0.08000, 0.41569, 0.00000], -[490, 0.27000, 0.19053, 0.00000], -[491, 0.31000, 0.15588, 0.00000], -[492, 0.05826, 0.44992, 0.00000], -[493, 0.09000, 0.39837, 0.00000], -[494, 0.10000, 0.38105, 0.00000], -[495, 0.23000, 0.22517, 0.00000], -[496, 0.00000, 0.56000, 0.00000], -[497, 0.56000, 0.00000, 0.00000], -[498, 0.35000, 0.12124, 0.00000], -[499, 0.18000, 0.27713, 0.00000], -[500, 0.04511, 0.46637, 0.00000], -[501, 0.11000, 0.36373, 0.00000], -[502, 0.45173, 0.05179, 0.00000], -[503, 0.12000, 0.34641, 0.00000], -[504, 0.28000, 0.17321, 0.00000], -[505, 0.48000, 0.03464, 0.00000], -[506, 0.42000, 0.06928, 0.00000], -[507, 0.19000, 0.25981, 0.00000], -[508, 0.32000, 0.13856, 0.00000], -[509, 0.24000, 0.20785, 0.00000], -[510, 0.39000, 0.08660, 0.00000], -[511, 0.13000, 0.32909, 0.00000], -[512, 0.02989, 0.48240, 0.00000], -[513, 0.02000, 0.50000, 0.00000], -[514, 0.50000, 0.02000, 0.00000], -[515, 0.00000, 0.54000, 0.00000], -[516, 0.54000, 0.00000, 0.00000], -[517, 0.36000, 0.10392, 0.00000], -[518, 0.14000, 0.31177, 0.00000], -[519, 0.20000, 0.24249, 0.00000], -[520, 0.29000, 0.15588, 0.00000], -[521, 0.25000, 0.19053, 0.00000], -[522, 0.15000, 0.29445, 0.00000], -[523, 0.33000, 0.12124, 0.00000], -[524, 0.46164, 0.03458, 0.00000], -[525, 0.43000, 0.05196, 0.00000], -[526, 0.21000, 0.22517, 0.00000], -[527, 0.06000, 0.41569, 0.00000], -[528, 0.04890, 0.43303, 0.00000], -[529, 0.40000, 0.06928, 0.00000], -[530, 0.07000, 0.39837, 0.00000], -[531, 0.16000, 0.27713, 0.00000], -[532, 0.08000, 0.38105, 0.00000], -[533, 0.00000, 0.52000, 0.00000], -[534, 0.52000, 0.00000, 0.00000], -[535, 0.03656, 0.44965, 0.00000], -[536, 0.26000, 0.17321, 0.00000], -[537, 0.37000, 0.08660, 0.00000], -[538, 0.30000, 0.13856, 0.00000], -[539, 0.09000, 0.36373, 0.00000], -[540, 0.22000, 0.20785, 0.00000], -[541, 0.17000, 0.25981, 0.00000], -[542, 0.10000, 0.34641, 0.00000], -[543, 0.34000, 0.10392, 0.00000], -[544, 0.11000, 0.32909, 0.00000], -[545, 0.47167, 0.01777, 0.00000], -[546, 0.02147, 0.46469, 0.00000], -[547, 0.27000, 0.15588, 0.00000], -[548, 0.44000, 0.03464, 0.00000], -[549, 0.18000, 0.24249, 0.00000], -[550, 0.41000, 0.05196, 0.00000], -[551, 0.12000, 0.31177, 0.00000], -[552, 0.23000, 0.19053, 0.00000], -[553, 0.31000, 0.12124, 0.00000], -[554, 0.50000, 0.00000, 0.00000], -[555, 0.00000, 0.50000, 0.00000], -[556, 0.38000, 0.06928, 0.00000], -[557, 0.13000, 0.29445, 0.00000], -[558, 0.19000, 0.22517, 0.00000], -[559, 0.35000, 0.08660, 0.00000], -[560, 0.28000, 0.13856, 0.00000], -[561, 0.24000, 0.17321, 0.00000], -[562, 0.14000, 0.27713, 0.00000], -[563, 0.04000, 0.41569, 0.00000], -[564, 0.02833, 0.43418, 0.00000], -[565, 0.05000, 0.39837, 0.00000], -[566, 0.32000, 0.10392, 0.00000], -[567, 0.06000, 0.38105, 0.00000], -[568, 0.20000, 0.20785, 0.00000], -[569, 0.45000, 0.01732, 0.00000], -[570, 0.42000, 0.03464, 0.00000], -[571, 0.01727, 0.44970, 0.00000], -[572, 0.07000, 0.36373, 0.00000], -[573, 0.15000, 0.25981, 0.00000], -[574, 0.00000, 0.48000, 0.00000], -[575, 0.48000, 0.00000, 0.00000], -[576, 0.39000, 0.05196, 0.00000], -[577, 0.08000, 0.34641, 0.00000], -[578, 0.25000, 0.15588, 0.00000], -[579, 0.36000, 0.06928, 0.00000], -[580, 0.29000, 0.12124, 0.00000], -[581, 0.09000, 0.32909, 0.00000], -[582, 0.21000, 0.19053, 0.00000], -[583, 0.16000, 0.24249, 0.00000], -[584, 0.33000, 0.08660, 0.00000], -[585, 0.10000, 0.31177, 0.00000], -[586, 0.17000, 0.22517, 0.00000], -[587, 0.26000, 0.13856, 0.00000], -[588, 0.11000, 0.29445, 0.00000], -[589, 0.43000, 0.01732, 0.00000], -[590, 0.00000, 0.46000, 0.00000], -[591, 0.46000, 0.00000, 0.00000], -[592, 0.40000, 0.03464, 0.00000], -[593, 0.22000, 0.17321, 0.00000], -[594, 0.30000, 0.10392, 0.00000], -[595, 0.37000, 0.05196, 0.00000], -[596, 0.12000, 0.27713, 0.00000], -[597, 0.18000, 0.20785, 0.00000], -[598, 0.02000, 0.41569, 0.00000], -[599, 0.34000, 0.06928, 0.00000], -[600, 0.04000, 0.38105, 0.00000], -[601, 0.13000, 0.25981, 0.00000], -[602, 0.27000, 0.12124, 0.00000], -[603, 0.23000, 0.15588, 0.00000], -[604, 0.02833, 0.39864, 0.00000], -[605, 0.05000, 0.36373, 0.00000], -[606, 0.31000, 0.08660, 0.00000], -[607, 0.06000, 0.34641, 0.00000], -[608, 0.19000, 0.19053, 0.00000], -[609, 0.14000, 0.24249, 0.00000], -[610, 0.00000, 0.44000, 0.00000], -[611, 0.44000, 0.00000, 0.00000], -[612, 0.41000, 0.01732, 0.00000], -[613, 0.07000, 0.32909, 0.00000], -[614, 0.38000, 0.03464, 0.00000], -[615, 0.24000, 0.13856, 0.00000], -[616, 0.08000, 0.31177, 0.00000], -[617, 0.35000, 0.05196, 0.00000], -[618, 0.28000, 0.10392, 0.00000], -[619, 0.15000, 0.22517, 0.00000], -[620, 0.20000, 0.17321, 0.00000], -[621, 0.09000, 0.29445, 0.00000], -[622, 0.32000, 0.06928, 0.00000], -[623, 0.10000, 0.27713, 0.00000], -[624, 0.16000, 0.20785, 0.00000], -[625, 0.25000, 0.12124, 0.00000], -[626, 0.00000, 0.42000, 0.00000], -[627, 0.42000, 0.00000, 0.00000], -[628, 0.21000, 0.15588, 0.00000], -[629, 0.39000, 0.01732, 0.00000], -[630, 0.29000, 0.08660, 0.00000], -[631, 0.11000, 0.25981, 0.00000], -[632, 0.36000, 0.03464, 0.00000], -[633, 0.02000, 0.38105, 0.00000], -[634, 0.17000, 0.19053, 0.00000], -[635, 0.33000, 0.05196, 0.00000], -[636, 0.12000, 0.24249, 0.00000], -[637, 0.02833, 0.36311, 0.00000], -[638, 0.22000, 0.13856, 0.00000], -[639, 0.26000, 0.10392, 0.00000], -[640, 0.03865, 0.34634, 0.00000], -[641, 0.05000, 0.32909, 0.00000], -[642, 0.18000, 0.17321, 0.00000], -[643, 0.30000, 0.06928, 0.00000], -[644, 0.06000, 0.31177, 0.00000], -[645, 0.13000, 0.22517, 0.00000], -[646, 0.00000, 0.40000, 0.00000], -[647, 0.40000, 0.00000, 0.00000], -[648, 0.37000, 0.01732, 0.00000], -[649, 0.07000, 0.29445, 0.00000], -[650, 0.23000, 0.12124, 0.00000], -[651, 0.14000, 0.20785, 0.00000], -[652, 0.27000, 0.08660, 0.00000], -[653, 0.34000, 0.03464, 0.00000], -[654, 0.19000, 0.15588, 0.00000], -[655, 0.08000, 0.27713, 0.00000], -[656, 0.31000, 0.05196, 0.00000], -[657, 0.09000, 0.25981, 0.00000], -[658, 0.15000, 0.19053, 0.00000], -[659, 0.24000, 0.10392, 0.00000], -[660, 0.20000, 0.13856, 0.00000], -[661, 0.10000, 0.24249, 0.00000], -[662, 0.00000, 0.38000, 0.00000], -[663, 0.38000, 0.00000, 0.00000], -[664, 0.28000, 0.06928, 0.00000], -[665, 0.02000, 0.34641, 0.00000], -[666, 0.35000, 0.01732, 0.00000], -[667, 0.16000, 0.17321, 0.00000], -[668, 0.11000, 0.22517, 0.00000], -[669, 0.32000, 0.03464, 0.00000], -[670, 0.21000, 0.12124, 0.00000], -[671, 0.25000, 0.08660, 0.00000], -[672, 0.03833, 0.31188, 0.00000], -[673, 0.05000, 0.29445, 0.00000], -[674, 0.17000, 0.15588, 0.00000], -[675, 0.12000, 0.20785, 0.00000], -[676, 0.29000, 0.05196, 0.00000], -[677, 0.02358, 0.32929, 0.00000], -[678, 0.06000, 0.27713, 0.00000], -[679, 0.00000, 0.36000, 0.00000], -[680, 0.36000, 0.00000, 0.00000], -[681, 0.22000, 0.10392, 0.00000], -[682, 0.13000, 0.19053, 0.00000], -[683, 0.07000, 0.25981, 0.00000], -[684, 0.26000, 0.06928, 0.00000], -[685, 0.18000, 0.13856, 0.00000], -[686, 0.33000, 0.01732, 0.00000], -[687, 0.08000, 0.24249, 0.00000], -[688, 0.30000, 0.03464, 0.00000], -[689, 0.14000, 0.17321, 0.00000], -[690, 0.23000, 0.08660, 0.00000], -[691, 0.19000, 0.12124, 0.00000], -[692, 0.09000, 0.22517, 0.00000], -[693, 0.27000, 0.05196, 0.00000], -[694, 0.15000, 0.15588, 0.00000], -[695, 0.00000, 0.34000, 0.00000], -[696, 0.34000, 0.00000, 0.00000], -[697, 0.10000, 0.20785, 0.00000], -[698, 0.01805, 0.31131, 0.00000], -[699, 0.02833, 0.29537, 0.00000], -[700, 0.31000, 0.01732, 0.00000], -[701, 0.04035, 0.27774, 0.00000], -[702, 0.20000, 0.10392, 0.00000], -[703, 0.24000, 0.06928, 0.00000], -[704, 0.11000, 0.19053, 0.00000], -[705, 0.16000, 0.13856, 0.00000], -[706, 0.05041, 0.26038, 0.00000], -[707, 0.28000, 0.03464, 0.00000], -[708, 0.06000, 0.24249, 0.00000], -[709, 0.12000, 0.17321, 0.00000], -[710, 0.21000, 0.08660, 0.00000], -[711, 0.17000, 0.12124, 0.00000], -[712, 0.25000, 0.05196, 0.00000], -[713, 0.00000, 0.32000, 0.00000], -[714, 0.32000, 0.00000, 0.00000], -[715, 0.07000, 0.22517, 0.00000], -[716, 0.13000, 0.15588, 0.00000], -[717, 0.29000, 0.01732, 0.00000], -[718, 0.08000, 0.20785, 0.00000], -[719, 0.22000, 0.06928, 0.00000], -[720, 0.18000, 0.10392, 0.00000], -[721, 0.03336, 0.26203, 0.00000], -[722, 0.26000, 0.03464, 0.00000], -[723, 0.14000, 0.13856, 0.00000], -[724, 0.02000, 0.27713, 0.00000], -[725, 0.09000, 0.19053, 0.00000], -[726, 0.00000, 0.30000, 0.00000], -[727, 0.30000, 0.00000, 0.00000], -[728, 0.19000, 0.08660, 0.00000], -[729, 0.23000, 0.05196, 0.00000], -[730, 0.10000, 0.17321, 0.00000], -[731, 0.03870, 0.24487, 0.00000], -[732, 0.15000, 0.12124, 0.00000], -[733, 0.27000, 0.01732, 0.00000], -[734, 0.11000, 0.15588, 0.00000], -[735, 0.04799, 0.22626, 0.00000], -[736, 0.20000, 0.06928, 0.00000], -[737, 0.16000, 0.10392, 0.00000], -[738, 0.24000, 0.03464, 0.00000], -[739, 0.06000, 0.20785, 0.00000], -[740, 0.12000, 0.13856, 0.00000], -[741, 0.00000, 0.28000, 0.00000], -[742, 0.28000, 0.00000, 0.00000], -[743, 0.07000, 0.19053, 0.00000], -[744, 0.21000, 0.05196, 0.00000], -[745, 0.17000, 0.08660, 0.00000], -[746, 0.25000, 0.01732, 0.00000], -[747, 0.01732, 0.25000, 0.00000], -[748, 0.13000, 0.12124, 0.00000], -[749, 0.08000, 0.17321, 0.00000], -[750, 0.18000, 0.06928, 0.00000], -[751, 0.22000, 0.03464, 0.00000], -[752, 0.09000, 0.15588, 0.00000], -[753, 0.14000, 0.10392, 0.00000], -[754, 0.00000, 0.26000, 0.00000], -[755, 0.26000, 0.00000, 0.00000], -[756, 0.02265, 0.22842, 0.00000], -[757, 0.10000, 0.13856, 0.00000], -[758, 0.03661, 0.20878, 0.00000], -[759, 0.19000, 0.05196, 0.00000], -[760, 0.15000, 0.08660, 0.00000], -[761, 0.23000, 0.01732, 0.00000], -[762, 0.04826, 0.19069, 0.00000], -[763, 0.11000, 0.12124, 0.00000], -[764, 0.06000, 0.17321, 0.00000], -[765, 0.16000, 0.06928, 0.00000], -[766, 0.20000, 0.03464, 0.00000], -[767, 0.12000, 0.10392, 0.00000], -[768, 0.07000, 0.15588, 0.00000], -[769, 0.00000, 0.24000, 0.00000], -[770, 0.24000, 0.00000, 0.00000], -[771, 0.17000, 0.05196, 0.00000], -[772, 0.08000, 0.13856, 0.00000], -[773, 0.21000, 0.01732, 0.00000], -[774, 0.01764, 0.20917, 0.00000], -[775, 0.13000, 0.08660, 0.00000], -[776, 0.09000, 0.12124, 0.00000], -[777, 0.18000, 0.03464, 0.00000], -[778, 0.14000, 0.06928, 0.00000], -[779, 0.00000, 0.22000, 0.00000], -[780, 0.22000, 0.00000, 0.00000], -[781, 0.03783, 0.17316, 0.00000], -[782, 0.02259, 0.19055, 0.00000], -[783, 0.10000, 0.10392, 0.00000], -[784, 0.05000, 0.15588, 0.00000], -[785, 0.15000, 0.05196, 0.00000], -[786, 0.19000, 0.01732, 0.00000], -[787, 0.06000, 0.13856, 0.00000], -[788, 0.11000, 0.08660, 0.00000], -[789, 0.07000, 0.12124, 0.00000], -[790, 0.16000, 0.03464, 0.00000], -[791, 0.00000, 0.20000, 0.00000], -[792, 0.20000, 0.00000, 0.00000], -[793, 0.12000, 0.06928, 0.00000], -[794, 0.08000, 0.10392, 0.00000], -[795, 0.01777, 0.17206, 0.00000], -[796, 0.17000, 0.01732, 0.00000], -[797, 0.02833, 0.15657, 0.00000], -[798, 0.13000, 0.05196, 0.00000], -[799, 0.09000, 0.08660, 0.00000], -[800, 0.04000, 0.13856, 0.00000], -[801, 0.14000, 0.03464, 0.00000], -[802, 0.00000, 0.18000, 0.00000], -[803, 0.18000, 0.00000, 0.00000], -[804, 0.05000, 0.12124, 0.00000], -[805, 0.10000, 0.06928, 0.00000], -[806, 0.06000, 0.10392, 0.00000], -[807, 0.15000, 0.01732, 0.00000], -[808, 0.11000, 0.05196, 0.00000], -[809, 0.07000, 0.08660, 0.00000], -[810, 0.02000, 0.13856, 0.00000], -[811, 0.00000, 0.16000, 0.00000], -[812, 0.16000, 0.00000, 0.00000], -[813, 0.12000, 0.03464, 0.00000], -[814, 0.08000, 0.06928, 0.00000], -[815, 0.02833, 0.12104, 0.00000], -[816, 0.13000, 0.01732, 0.00000], -[817, 0.04000, 0.10392, 0.00000], -[818, 0.09000, 0.05196, 0.00000], -[819, 0.05000, 0.08660, 0.00000], -[820, 0.00000, 0.14000, 0.00000], -[821, 0.14000, 0.00000, 0.00000], -[822, 0.10000, 0.03464, 0.00000], -[823, 0.06000, 0.06928, 0.00000], -[824, 0.11000, 0.01732, 0.00000], -[825, 0.02000, 0.10392, 0.00000], -[826, 0.07000, 0.05196, 0.00000], -[827, 0.00000, 0.12000, 0.00000], -[828, 0.12000, 0.00000, 0.00000], -[829, 0.08000, 0.03464, 0.00000], -[830, 0.02833, 0.08550, 0.00000], -[831, 0.03801, 0.06894, 0.00000], -[832, 0.09000, 0.01732, 0.00000], -[833, 0.04827, 0.05179, 0.00000], -[834, 0.00000, 0.10000, 0.00000], -[835, 0.10000, 0.00000, 0.00000], -[836, 0.06000, 0.03464, 0.00000], -[837, 0.07000, 0.01732, 0.00000], -[838, 0.01793, 0.06915, 0.00000], -[839, 0.00000, 0.08000, 0.00000], -[840, 0.08000, 0.00000, 0.00000], -[841, 0.02327, 0.05131, 0.00000], -[842, 0.03836, 0.03458, 0.00000], -[843, 0.05000, 0.01732, 0.00000], -[844, 0.00000, 0.06000, 0.00000], -[845, 0.06000, 0.00000, 0.00000], -[846, 0.02000, 0.03464, 0.00000], -[847, 0.02833, 0.01777, 0.00000], -[848, 0.00000, 0.04000, 0.00000], -[849, 0.04000, 0.00000, 0.00000], -[850, 0.00000, 0.02000, 0.00000], -[851, 0.02000, 0.00000, 0.00000], -[852, 0.00000, 0.00000, 0.00000] -]) - diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.prb b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.prb deleted file mode 100644 index f54441733ea6..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.prb +++ /dev/null @@ -1,8 +0,0 @@ -PROBLEM DATA -QUESTION: END_TIME -VALUE: 0.1 -QUESTION: DELTA_TIME -VALUE: 0.001 -END PROBLEM DATA -INTERVAL DATA -END INTERVAL DATA diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.prop b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.prop deleted file mode 100644 index ed7457a9a846..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.prop +++ /dev/null @@ -1,3 +0,0 @@ -PROPERTIES[1][END_TIME] = 0.1; -PROPERTIES[1][DELTA_TIME] = 0.001; - diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.py b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.py deleted file mode 100644 index 6871b068512b..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.py +++ /dev/null @@ -1,150 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# -# -# setting the domain size for the problem to be solved -domain_size = 2 - -# -# -# ATTENTION: here the order is important - -# including kratos path -kratos_path = '../../../../' # kratos_root/ -kratos_benchmarking_path = '../../../../benchmarking' # kratos_root/benchmarking - -import sys -sys.path.append(kratos_path) -sys.path.append(kratos_benchmarking_path) - -# importing Kratos main library -from KratosMultiphysics import * - -# importing applications -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * - -import benchmarking - -# from now on the order is not anymore crucial -# -# - - -def FindNode(node_list, x, y, z): - for node in node_list: - if ((node.X - x) ** 2 + (node.Y - y) ** 2 + (node.Z - z) ** 2 < 0.0000001): - return node - - -def BenchmarkCheck(time, node1, node2): - benchmarking.Output(time, "Time") - benchmarking.Output(node1.GetSolutionStepValue(PRESSURE), "Node 1 pressure", 1.0) - benchmarking.Output(node2.GetSolutionStepValue(PRESSURE), "Node 2 pressure", 1.0) - - -# defining a model part -model_part = ModelPart("FluidPart"); -print ("aaa") - -# importing the solver files and adding the variables -import pfem_solver_ale -pfem_solver_ale.AddVariables(model_part) - -# reading a model -gid_mode_flag = GiDPostMode.GiD_PostBinary -use_multifile = MultiFileFlag.MultipleFiles -deformed_print_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteConditions -gid_io = GidIO("dam2d", gid_mode_flag, use_multifile, deformed_print_flag, write_conditions) -gid_io.ReadModelPart(model_part) -print (model_part) - -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(3) - -# adding dofs -pfem_solver_ale.AddDofs(model_part) - -# setting the limits of the bounding box -box_corner1 = Vector(3) -box_corner1[0] = -0.1 -box_corner1[1] = -0.1 -box_corner1[2] = -0.1 -box_corner2 = Vector(3) -box_corner2[0] = 1.1 -box_corner2[1] = 1.1 -box_corner2[2] = -0.0 - -# creating a fluid solver object -name = str("dam2d") -solver = pfem_solver_ale.PFEMSolver(model_part, name, box_corner1, box_corner2, domain_size) -solver.laplacian_form = 2 -solver.echo_level = 0 -solver.prediction_order = 1 -solver.predictor_corrector = True -solver.smooth = True -solver.alpha_shape = 1.2 -solver.max_press_its = 3; -# solver.vel_toll = 1e-12 -# solver.max_vel_its = 20; -# solver.echo_level = 2 -solver.pressure_linear_solver = SkylineLUFactorizationSolver() -solver.velocity_linear_solver = SkylineLUFactorizationSolver() - - -gravity = Vector(3) -gravity[0] = 0.00 -gravity[1] = -9.81 -gravity[2] = 0.0 -for node in model_part.Nodes: - node.SetSolutionStepValue(VISCOSITY, 0, 0.000001) - node.SetSolutionStepValue(DENSITY, 0, 1000.00000) - node.SetSolutionStepValue(BODY_FORCE, 0, gravity) - -Dt = 0.01 -nsteps = 1000 -output_Dt = 0.05 -min_dt = 0.005 -max_dt = 0.02 - -safety_factor = 0.5; - -# - -node_1 = FindNode(model_part.Nodes, 0.5, 0.0, 0.0) -node_2 = FindNode(model_part.Nodes, 0.24, 0.0, 0.0) - -# - -# initializing the solver -solver.Initialize(Dt, output_Dt) - -time = Dt -for step in range(0, nsteps): - print ("solution step =", step) - - new_Dt = solver.EstimateDeltaTime(min_dt, max_dt) - # print "time = ", time, " new_Dt= ",new_Dt," step = ", step - - # new_Dt = Dt - - time = time + new_Dt * safety_factor - - # time = Dt*step - model_part.CloneTimeStep(time) - - print (time) - # print model_part.ProcessInfo()[TIME] - - # solving the fluid problem - print ("qui") - if(step > 3): - solver.Solve(time, gid_io) -# if(step > 4): -# solver.box_corner2[1] = 0.1 - print ("li") - - BenchmarkCheck(time, node_1, node_2) - -print ("solution finished") diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.rdr b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.rdr deleted file mode 100644 index b3ea43a9cf0c..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.rdr and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.uni b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.uni deleted file mode 100644 index 0468052e4eaa..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d.uni +++ /dev/null @@ -1,2 +0,0 @@ -model: m -problem: INTERNATIONAL diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d_benchmark.py b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d_benchmark.py deleted file mode 100644 index e2bfe76c976c..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d_benchmark.py +++ /dev/null @@ -1,7 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import benchmarking - - -def Run(): - print("Running dam2d.py...") - return benchmarking.RunBenchmark("dam2d.py", "dam2d_ref.txt") diff --git a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d_build_reference.py b/applications/PFEMapplication/test_examples/dam2d.gid/dam2d_build_reference.py deleted file mode 100644 index 4204f1d18d92..000000000000 --- a/applications/PFEMapplication/test_examples/dam2d.gid/dam2d_build_reference.py +++ /dev/null @@ -1,5 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import benchmarking - -print("Building reference data for dam2d.py...") -benchmarking.BuildReferenceData("dam2d.py", "dam2d_ref.txt") diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt.py b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt.py deleted file mode 100755 index 965982c133df..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt.py +++ /dev/null @@ -1,174 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# import the configuration data as read from the GiD -import pfem_nonewtonian_var - -# -# -# setting the domain size for the problem to be solved -domain_size = pfem_nonewtonian_var.domain_size - -# -# -# ATTENTION: here the order is important - -# including kratos path -kratos_path = '../../../../' # kratos_root/ -kratos_benchmarking_path = '../../../../benchmarking' # kratos_root/benchmarking -import sys -sys.path.append(kratos_path) -sys.path.append(kratos_benchmarking_path) -import benchmarking - -# importing Kratos main library -from KratosMultiphysics import * - -# from KratosMultiphysics.StructuralApplication import * -from KratosMultiphysics.IncompressibleFluidApplication import * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingFluidApplication import * -from KratosMultiphysics.ExternalSolversApplication import * - - -# from now on the order is not anymore crucial -# -# - - -def NodeFinder(node_list, X, Y, Z): - for node in node_list: - if((node.X - X) ** 2 + (node.Y - Y) ** 2 + (node.Z -Z)**2 < .0001): - return node - - -def BenchmarkCheck(time, node1): - benchmarking.Output(time, "Time", 0.0001, 0.0001) -# print "IIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIIII" - benchmarking.Output(node1.GetSolutionStepValue(PRESSURE), "Node 1 pressure", 0.01, .00001) - benchmarking.Output(node1.GetSolutionStepValue(VELOCITY_Y), "Node 2 velocity_y", 0.01, .00001) - - -# defining a model part -model_part = ModelPart("FluidPart"); - -# importing the solver files and adding the variables -SolverType = pfem_nonewtonian_var.SolverType - -if(SolverType == "pfem_solver_ale"): - import pfem_solver_ale - pfem_solver_ale.AddVariables(model_part) -elif(SolverType == "monolithic_solver_lagrangian"): - import monolithic_solver_lagrangian_nonnewtonian - monolithic_solver_lagrangian_nonnewtonian.AddVariables(model_part) -else: - raise "solver type not supported: options are FractionalStep - Monolithic" - - -# reading a model -name = pfem_nonewtonian_var.problem_name - -gid_mode = GiDPostMode.GiD_PostBinary -multifile = MultiFileFlag.MultipleFiles -deformed_mesh_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteElementsOnly -gid_io = GidIO(name, gid_mode, multifile, deformed_mesh_flag, write_conditions) -model_part_io = ModelPartIO(name) -model_part_io.ReadModelPart(model_part) - -# check to ensure that no node has zero density or pressure -for node in model_part.Nodes: - node.SetSolutionStepValue(DENSITY, 0, pfem_nonewtonian_var.Density) - node.SetSolutionStepValue(VISCOSITY, 0, pfem_nonewtonian_var.Viscosity) - node.SetSolutionStepValue(BODY_FORCE_X, 0, pfem_nonewtonian_var.Gravity_X) - node.SetSolutionStepValue(BODY_FORCE_Y, 0, pfem_nonewtonian_var.Gravity_Y) - node.SetSolutionStepValue(BODY_FORCE_Z, 0, pfem_nonewtonian_var.Gravity_Z) - node.SetSolutionStepValue(YIELD_STRESS, 0, pfem_nonewtonian_var.YieldStress) -# if(node.GetSolutionStepValue(DENSITY) == 0.0): -# print "node ",node.Id," has zero density!" -# raise 'node with zero density found' -# if(node.GetSolutionStepValue(VISCOSITY) == 0.0): -# print "node ",node.Id," has zero viscosity!" -# raise 'node with zero density found' - - -mesh_name = 0.0 -gid_io.InitializeMesh(mesh_name); -gid_io.WriteMesh((model_part).GetMesh()); -gid_io.FinalizeMesh() - -print(model_part) -print(model_part.Properties) - -# setting the limits of the bounding box -box_corner1 = Vector(3); -box_corner1[0] = pfem_nonewtonian_var.min_x; -box_corner1[1] = pfem_nonewtonian_var.min_y; -box_corner1[2] = pfem_nonewtonian_var.min_z; -box_corner2 = Vector(3); -box_corner2[0] = pfem_nonewtonian_var.max_x; -box_corner2[1] = pfem_nonewtonian_var.max_y; -box_corner2[2] = pfem_nonewtonian_var.max_z; - -# time setting -output_Dt = pfem_nonewtonian_var.output_Dt -max_dt = pfem_nonewtonian_var.max_dt -min_dt = pfem_nonewtonian_var.min_dt -safety_factor = pfem_nonewtonian_var.safety_factor -nsteps = pfem_nonewtonian_var.nsteps - -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(2) - -if(SolverType == "pfem_solver_ale"): - print("change the solver: testing monolithic solver lagrangian, not pfem_soler_ale") -# adding dofs -# pfem_solver_ale.AddDofs(model_part) -# creating a fluid solver object -# name = str("dam2d") -# solver = pfem_solver_ale.PFEMSolver(model_part,name,box_corner1,box_corner2,domain_size) -# solver.laplacian_form = pfem_nonewtonian_var.laplacian_form -# solver.echo_level = 0 -# solver.prediction_order = 1 -# solver.predictor_corrector = True -# solver.smooth = True -# solver.alpha_shape = 1.2 -# solver.max_press_its = 3; -# initializing the solver -# initial_dt = 0.001*min_dt -# solver.Initialize(initial_dt,output_Dt) -elif(SolverType == "monolithic_solver_lagrangian"): - # adding dofs - monolithic_solver_lagrangian_nonnewtonian.AddDofs(model_part) - solver = monolithic_solver_lagrangian_nonnewtonian.MonolithicSolver(model_part, domain_size, box_corner1, box_corner2) - oss_swith = pfem_nonewtonian_var.use_oss - dynamic_tau = pfem_nonewtonian_var.dynamic_tau - solver.echo_level = 2 - model_part.ProcessInfo.SetValue(OSS_SWITCH, oss_swith); - model_part.ProcessInfo.SetValue(DYNAMIC_TAU, dynamic_tau); -# pPrecond = DiagonalPreconditioner() -# solver.linear_solver = BICGSTABSolver(1e-6, 5000,pPrecond) - solver.linear_solver = SuperLUSolver() - solver.Initialize(output_Dt) - -# -back_node = NodeFinder(model_part.Nodes, 0.414976, 0.50122, 0.0) -print(back_node) - -# -time = 0.0 -for step in range(0, nsteps): - print("line49") - - new_Dt = solver.EstimateDeltaTime(min_dt, max_dt) - - time = time + new_Dt * safety_factor - - model_part.CloneTimeStep(time) - - print(time) - - # solving the fluid problem - if(step > 3): - solver.Solve(time, gid_io) - BenchmarkCheck(time, back_node) - -print("solution finished ***********************") diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.cnd b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.cnd deleted file mode 100644 index d161d79c59c6..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.cnd +++ /dev/null @@ -1,1084 +0,0 @@ -BOOK:Nodal Values -NUMBER: 1 CONDITION: point_DISPLACEMENT -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 2 CONDITION: line_DISPLACEMENT -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 3 CONDITION: surface_DISPLACEMENT -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 4 CONDITION: volume_DISPLACEMENT -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 5 CONDITION: point_VELOCITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 6 CONDITION: line_VELOCITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 7 CONDITION: surface_VELOCITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 8 CONDITION: volume_VELOCITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 9 CONDITION: point_MESH_VELOCITY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 10 CONDITION: line_MESH_VELOCITY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 11 CONDITION: surface_MESH_VELOCITY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 12 CONDITION: volume_MESH_VELOCITY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: MESH_VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 0 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 0 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: MESH_VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 0 -QUESTION: Z_Value -VALUE: 0.0 -END CONDITION -NUMBER: 13 CONDITION: point_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 14 CONDITION: line_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 15 CONDITION: surface_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 16 CONDITION: volume_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 17 CONDITION: point_EXTERNAL_PRESSURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 18 CONDITION: line_EXTERNAL_PRESSURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 19 CONDITION: surface_EXTERNAL_PRESSURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 20 CONDITION: volume_EXTERNAL_PRESSURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: EXTERNAL_PRESSURE -VALUE: 0.0 -END CONDITION -NUMBER: 21 CONDITION: point_IS_INTERFACE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 22 CONDITION: line_IS_INTERFACE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 23 CONDITION: surface_IS_INTERFACE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 24 CONDITION: volume_IS_INTERFACE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_INTERFACE#CB#(1.0) -VALUE: 1.0 -END CONDITION -NUMBER: 25 CONDITION: point_FLAG_VARIABLE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 26 CONDITION: line_FLAG_VARIABLE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 27 CONDITION: surface_FLAG_VARIABLE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 28 CONDITION: volume_FLAG_VARIABLE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: FLAG_VARIABLE#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 29 CONDITION: point_IS_BOUNDARY -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 30 CONDITION: line_IS_BOUNDARY -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 31 CONDITION: surface_IS_BOUNDARY -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 32 CONDITION: volume_IS_BOUNDARY -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_BOUNDARY#CB#(1.0,2.0,3.0,4.0,5.0) -VALUE: 1.0 -END CONDITION -NUMBER: 33 CONDITION: point_IS_FREE_SURFACE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 34 CONDITION: line_IS_FREE_SURFACE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 35 CONDITION: surface_IS_FREE_SURFACE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 36 CONDITION: volume_IS_FREE_SURFACE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 37 CONDITION: point_IS_STRUCTURE -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 38 CONDITION: line_IS_STRUCTURE -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 39 CONDITION: surface_IS_STRUCTURE -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -NUMBER: 40 CONDITION: volume_IS_STRUCTURE -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0,0.0) -VALUE: 1.0 -END CONDITION -BOOK:Elements -NUMBER: 41 CONDITION: surface_Fluid2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 42 CONDITION: surface_ASGS2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 43 CONDITION: surface_NoNewtonianASGS2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 44 CONDITION: volume_NoNewtonianASGS3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 45 CONDITION: volume_Fluid3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 46 CONDITION: volume_ASGS3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 47 CONDITION: surface_Fluid2DCoupled -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 48 CONDITION: volume_Fluid3DCoupled -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -BOOK:Conditions -NUMBER: 49 CONDITION: line_Condition2D -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 50 CONDITION: surface_Condition3D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 51 CONDITION: line_Fluid2DNeumann -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -NUMBER: 52 CONDITION: surface_Fluid3DNeumann -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -END CONDITION -BOOK:Model Parts -NUMBER: 53 CONDITION: point_WallBoundary -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -QUESTION: BEGINDISPLACEMENT -VALUE: BEGINDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDDISPLACEMENT -VALUE: ENDDISPLACEMENT -STATE: HIDDEN -QUESTION: BEGINIS_STRUCTURE -VALUE: BEGINIS_STRUCTURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_STRUCTURE -VALUE: ENDIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 54 CONDITION: line_WallBoundary -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -QUESTION: BEGINDISPLACEMENT -VALUE: BEGINDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDDISPLACEMENT -VALUE: ENDDISPLACEMENT -STATE: HIDDEN -QUESTION: BEGINIS_STRUCTURE -VALUE: BEGINIS_STRUCTURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_STRUCTURE -VALUE: ENDIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 55 CONDITION: surface_WallBoundary -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINVELOCITY -VALUE: BEGINVELOCITY -STATE: HIDDEN -QUESTION: VELOCITY_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDVELOCITY -VALUE: ENDVELOCITY -STATE: HIDDEN -QUESTION: BEGINDISPLACEMENT -VALUE: BEGINDISPLACEMENT -STATE: HIDDEN -QUESTION: DISPLACEMENT_X#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,X_Value,0.0,SET,Fix_X,#CURRENT#)(#DEFAULT#,RESTORE,X_Value,#CURRENT#,RESTORE,Fix_X,#CURRENT#) -QUESTION: Fix_X#CB#(1,0) -VALUE: 1 -QUESTION: X_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Y_Value,0.0,SET,Fix_Y,#CURRENT#)(#DEFAULT#,RESTORE,Y_Value,#CURRENT#,RESTORE,Fix_Y,#CURRENT#) -QUESTION: Fix_Y#CB#(1,0) -VALUE: 1 -QUESTION: Y_Value -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (0,SET,Z_Value,0.0,SET,Fix_Z,#CURRENT#)(#DEFAULT#,RESTORE,Z_Value,#CURRENT#,RESTORE,Fix_Z,#CURRENT#) -QUESTION: Fix_Z#CB#(1,0) -VALUE: 1 -QUESTION: Z_Value -VALUE: 0.0 -QUESTION: ENDDISPLACEMENT -VALUE: ENDDISPLACEMENT -STATE: HIDDEN -QUESTION: BEGINIS_STRUCTURE -VALUE: BEGINIS_STRUCTURE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_STRUCTURE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_STRUCTURE -VALUE: ENDIS_STRUCTURE -STATE: HIDDEN -END CONDITION -NUMBER: 56 CONDITION: point_FreeSurfaceBoundary -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINIS_FREE_SURFACE -VALUE: BEGINIS_FREE_SURFACE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_FREE_SURFACE -VALUE: ENDIS_FREE_SURFACE -STATE: HIDDEN -END CONDITION -NUMBER: 57 CONDITION: line_FreeSurfaceBoundary -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINIS_FREE_SURFACE -VALUE: BEGINIS_FREE_SURFACE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_FREE_SURFACE -VALUE: ENDIS_FREE_SURFACE -STATE: HIDDEN -END CONDITION -NUMBER: 58 CONDITION: surface_FreeSurfaceBoundary -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGINIS_FREE_SURFACE -VALUE: BEGINIS_FREE_SURFACE -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 0 -QUESTION: IS_FREE_SURFACE#CB#(1.0) -VALUE: 1.0 -QUESTION: ENDIS_FREE_SURFACE -VALUE: ENDIS_FREE_SURFACE -STATE: HIDDEN -END CONDITION -BOOK:Default -NUMBER: 59 CONDITION: point_Boundary -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DCondition2D -VALUE: BEGIN2DCondition2D -STATE: HIDDEN -QUESTION: END2DCondition2D -VALUE: END2DCondition2D -STATE: HIDDEN -QUESTION: BEGIN3DCondition3D -VALUE: BEGIN3DCondition3D -STATE: HIDDEN -QUESTION: END3DCondition3D -VALUE: END3DCondition3D -STATE: HIDDEN -QUESTION: BEGIN2DIS_BOUNDARY -VALUE: BEGIN2DIS_BOUNDARY -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: IS_BOUNDARY#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_BOUNDARY -VALUE: END2DIS_BOUNDARY -STATE: HIDDEN -END CONDITION -NUMBER: 60 CONDITION: line_Boundary -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DCondition2D -VALUE: BEGIN2DCondition2D -STATE: HIDDEN -QUESTION: END2DCondition2D -VALUE: END2DCondition2D -STATE: HIDDEN -QUESTION: BEGIN3DCondition3D -VALUE: BEGIN3DCondition3D -STATE: HIDDEN -QUESTION: END3DCondition3D -VALUE: END3DCondition3D -STATE: HIDDEN -QUESTION: BEGIN2DIS_BOUNDARY -VALUE: BEGIN2DIS_BOUNDARY -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: IS_BOUNDARY#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_BOUNDARY -VALUE: END2DIS_BOUNDARY -STATE: HIDDEN -END CONDITION -NUMBER: 61 CONDITION: surface_Boundary -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Automatic -VALUE: 0 -STATE: HIDDEN -QUESTION: BEGIN2DCondition2D -VALUE: BEGIN2DCondition2D -STATE: HIDDEN -QUESTION: END2DCondition2D -VALUE: END2DCondition2D -STATE: HIDDEN -QUESTION: BEGIN3DCondition3D -VALUE: BEGIN3DCondition3D -STATE: HIDDEN -QUESTION: END3DCondition3D -VALUE: END3DCondition3D -STATE: HIDDEN -QUESTION: BEGIN2DIS_BOUNDARY -VALUE: BEGIN2DIS_BOUNDARY -STATE: HIDDEN -QUESTION: Fixed#CB#(1,0) -VALUE: 1 -QUESTION: IS_BOUNDARY#CB#(1.0) -VALUE: 1.0 -QUESTION: END2DIS_BOUNDARY -VALUE: END2DIS_BOUNDARY -STATE: HIDDEN -END CONDITION diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.cond b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.cond deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.elem b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.elem deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.geo b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.geo deleted file mode 100644 index a447d527231a..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.geo and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.info b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.info deleted file mode 100644 index 7e8f81bd434a..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.info +++ /dev/null @@ -1,38650 +0,0 @@ -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: False -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosMKLSolversApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: True -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: True -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -importing KratosIncompressibleFluidApplication ... -KratosIncompressibleFluidApplication lib loaded -KratosIncompressibleFluidApplication application created -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing KratosIncompressibleFluidApplication... -Initializing KratosIncompressibleFluidApplication...Register completed -Initializing KratosIncompressibleFluidApplication...variables succesfully registered -Initializing KratosIncompressibleFluidApplication...elements succesfully registered -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosIncompressibleFluidApplication Succesfully imported -importing KratosPFEMApplication ... -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing Kratos PFEMApplication... -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosPFEMApplication Succesfully imported -importing KratosMeshingApplication ... -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing Kratos MeshingApplication... -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosMeshingApplication sucessfully imported -variables for the dynamic structural solution added correctly -dam2dNonNewt_Y1500 opened for io -dam2dNonNewt_Y1500.node opened for io -dam2dNonNewt_Y1500.prop opened for io -dam2dNonNewt_Y1500.elem opened for io -dam2dNonNewt_Y1500.cond opened for io -dam2dNonNewt_Y1500.init opened for io -initializing result files - Reading Nodes : 124 nodes read - Reading Elements : 138 NoNewtonianASGS2D read -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DISPLACEMENT_X -rVariable : DISPLACEMENT_X component of DISPLACEMENT variable #94 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DISPLACEMENT_Y -rVariable : DISPLACEMENT_Y component of DISPLACEMENT variable #95 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DISPLACEMENT_Z -rVariable : DISPLACEMENT_Z component of DISPLACEMENT variable #96 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VELOCITY_X -rVariable : VELOCITY_X component of VELOCITY variable #292 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VELOCITY_Y -rVariable : VELOCITY_Y component of VELOCITY variable #293 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VELOCITY_Z -rVariable : VELOCITY_Z component of VELOCITY variable #294 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : IS_BOUNDARY -rVariable : IS_BOUNDARY variable #148 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : IS_FREE_SURFACE -rVariable : IS_FREE_SURFACE variable #157 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : IS_STRUCTURE -rVariable : IS_STRUCTURE variable #164 -lines read : 777 -writing a 2D mesh -FluidPart model part - Buffer Size : 1 - Current solution step index : 0 - - Mesh 0 : - Number of Nodes : 124 - Number of Properties : 1 - Number of Elements : 138 - Number of Conditions : 32 - -Pointer vector set (size = 1) : -Properties - - -dofs for the monolithic solver added correctly -using the velocity Bossak Time Integration Scheme -line49 -Estimating delta time -0.01 -line49 -Estimating delta time -0.02 -line49 -Estimating delta time -0.03 -line49 -Estimating delta time -0.04 -line49 -Estimating delta time -0.05 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.05 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00167108 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1; expected ratio = 1e-07obtained abs = 3.81178e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1; expected ratio = 0.0001obtained abs = 305.807; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142598 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.404352; expected ratio = 1e-07obtained abs = 2.55815e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0795107; expected ratio = 0.0001obtained abs = 23.6575; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142813 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.300402; expected ratio = 1e-07obtained abs = 2.70847e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0397576; expected ratio = 0.0001obtained abs = 11.5558; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00144291 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.242001; expected ratio = 1e-07obtained abs = 2.87311e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0290922; expected ratio = 0.0001obtained abs = 8.3258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00144601 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.660310e+05 Mflops = 21.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.197649; expected ratio = 1e-07obtained abs = 2.9203e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0229992; expected ratio = 0.0001obtained abs = 6.49925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142813 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.651310e+05 Mflops = 10.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.163805; expected ratio = 1e-07obtained abs = 2.89091e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0189188; expected ratio = 0.0001obtained abs = 5.28302; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00143409 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.135238; expected ratio = 1e-07obtained abs = 2.75738e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162025; expected ratio = 0.0001obtained abs = 4.47567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00141382 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.109898; expected ratio = 1e-07obtained abs = 2.51538e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0138524; expected ratio = 0.0001obtained abs = 3.79007; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00145197 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.634030e+05 Mflops = 21.80 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0875234; expected ratio = 1e-07obtained abs = 2.19384e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01159; expected ratio = 0.0001obtained abs = 3.14542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00143003 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0683795; expected ratio = 1e-07obtained abs = 1.83856e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00879168; expected ratio = 0.0001obtained abs = 2.37305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00148916 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0524055; expected ratio = 1e-07obtained abs = 1.48604e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0073318; expected ratio = 0.0001obtained abs = 1.96884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00145411 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0395864; expected ratio = 1e-07obtained abs = 1.1681e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00570391; expected ratio = 0.0001obtained abs = 1.52542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.001441 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0295797; expected ratio = 1e-07obtained abs = 8.98912e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00432459; expected ratio = 0.0001obtained abs = 1.15287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142694 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0219359; expected ratio = 1e-07obtained abs = 6.81197e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00323265; expected ratio = 0.0001obtained abs = 0.859697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00145197 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0161923; expected ratio = 1e-07obtained abs = 5.10844e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00239687; expected ratio = 0.0001obtained abs = 0.636265; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00146103 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.651810e+05 Mflops = 10.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0119275; expected ratio = 1e-07obtained abs = 3.8065e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00177142; expected ratio = 0.0001obtained abs = 0.469591; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00144005 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00878646; expected ratio = 1e-07obtained abs = 2.82763e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00131052; expected ratio = 0.0001obtained abs = 0.347054; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00146198 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00648475; expected ratio = 1e-07obtained abs = 2.09961e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000974198; expected ratio = 0.0001obtained abs = 0.257789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142503 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00480241; expected ratio = 1e-07obtained abs = 1.56179e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000730001; expected ratio = 0.0001obtained abs = 0.193058; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142384 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00357338; expected ratio = 1e-07obtained abs = 1.16583e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000552802; expected ratio = 0.0001obtained abs = 0.146132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00141096 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00267435; expected ratio = 1e-07obtained abs = 8.74562e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000423752; expected ratio = 0.0001obtained abs = 0.111981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142694 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.651810e+05 Mflops = 21.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00201484; expected ratio = 1e-07obtained abs = 6.60016e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000329044; expected ratio = 0.0001obtained abs = 0.0869315; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00143695 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.651810e+05 Mflops = 10.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00152898; expected ratio = 1e-07obtained abs = 5.01486e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000258759; expected ratio = 0.0001obtained abs = 0.0683494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00144911 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00116908; expected ratio = 1e-07obtained abs = 3.83797e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000205874; expected ratio = 0.0001obtained abs = 0.0543723; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142503 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000900751; expected ratio = 1e-07obtained abs = 2.95907e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000165476; expected ratio = 0.0001obtained abs = 0.0436978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00140691 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.459600e+04 Mflops = 1.48 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000699219; expected ratio = 1e-07obtained abs = 2.29816e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134143; expected ratio = 0.0001obtained abs = 0.0354205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00145793 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00054666; expected ratio = 1e-07obtained abs = 1.79741e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000109497; expected ratio = 0.0001obtained abs = 0.0289108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.0014298 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000430233; expected ratio = 1e-07obtained abs = 1.41499e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.98716e-05; expected ratio = 0.0001obtained abs = 0.0237277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142813 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.651810e+05 Mflops = 21.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000340658; expected ratio = 1e-07obtained abs = 1.12062e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.40841e-05; expected ratio = 0.0001obtained abs = 0.0195587; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00143909 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.651810e+05 Mflops = 21.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000271203; expected ratio = 1e-07obtained abs = 8.92283e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.12812e-05; expected ratio = 0.0001obtained abs = 0.0161781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.06 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.06 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00144386 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.348827; expected ratio = 1e-07obtained abs = 0.000175962; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.163619; expected ratio = 0.0001obtained abs = 48.4656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00143003 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.238711; expected ratio = 1e-07obtained abs = 0.000158156; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0745011; expected ratio = 0.0001obtained abs = 21.0493; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00146389 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.143533; expected ratio = 1e-07obtained abs = 0.000111007; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0507273; expected ratio = 0.0001obtained abs = 13.8817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00143313 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.659820e+05 Mflops = 21.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0769245; expected ratio = 1e-07obtained abs = 6.44248e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0295949; expected ratio = 0.0001obtained abs = 7.94483; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00145197 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.659820e+05 Mflops = 10.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0384479; expected ratio = 1e-07obtained abs = 3.34732e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0148839; expected ratio = 0.0001obtained abs = 3.95931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00141788 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.018634; expected ratio = 1e-07obtained abs = 1.65239e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00732849; expected ratio = 0.0001obtained abs = 1.93961; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00146198 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00902666; expected ratio = 1e-07obtained abs = 8.07401e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00348635; expected ratio = 0.0001obtained abs = 0.920412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00143194 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.659820e+05 Mflops = 21.96 -Solve time = 0.02 -Solve flops = 2.458000e+04 Mflops = 1.47 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00449076; expected ratio = 1e-07obtained abs = 4.03321e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00167349; expected ratio = 0.0001obtained abs = 0.441279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00146294 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00236888; expected ratio = 1e-07obtained abs = 2.13165e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000844484; expected ratio = 0.0001obtained abs = 0.222557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142503 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00136857; expected ratio = 1e-07obtained abs = 1.23266e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000469991; expected ratio = 0.0001obtained abs = 0.123832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142694 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000876978; expected ratio = 1e-07obtained abs = 7.90249e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000297886; expected ratio = 0.0001obtained abs = 0.0784792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.001436 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.659820e+05 Mflops = 21.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0006126; expected ratio = 1e-07obtained abs = 5.52142e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000212142; expected ratio = 0.0001obtained abs = 0.0558886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00145292 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000452966; expected ratio = 1e-07obtained abs = 4.08311e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000162949; expected ratio = 0.0001obtained abs = 0.0429291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00159311 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000346582; expected ratio = 1e-07obtained abs = 3.12434e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000130489; expected ratio = 0.0001obtained abs = 0.0343783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00144696 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.659820e+05 Mflops = 21.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000270951; expected ratio = 1e-07obtained abs = 2.44263e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000106914; expected ratio = 0.0001obtained abs = 0.0281679; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142717 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000215104; expected ratio = 1e-07obtained abs = 1.9392e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.88238e-05; expected ratio = 0.0001obtained abs = 0.0234025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00141287 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000172923; expected ratio = 1e-07obtained abs = 1.55896e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.45243e-05; expected ratio = 0.0001obtained abs = 0.0196354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00141883 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000140595; expected ratio = 1e-07obtained abs = 1.26751e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.30345e-05; expected ratio = 0.0001obtained abs = 0.0166084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00138021 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000115548; expected ratio = 1e-07obtained abs = 1.04171e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.37123e-05; expected ratio = 0.0001obtained abs = 0.0141524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142097 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.59669e-05; expected ratio = 1e-07obtained abs = 8.65183e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.60981e-05; expected ratio = 0.0001obtained abs = 0.0121464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.07 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.07 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00144982 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.269757; expected ratio = 1e-07obtained abs = 0.000332733; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116708; expected ratio = 0.0001obtained abs = 33.3114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00141692 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.117211; expected ratio = 1e-07obtained abs = 0.000163742; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0812461; expected ratio = 0.0001obtained abs = 22.0488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00142002 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0430574; expected ratio = 1e-07obtained abs = 6.28282e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0309803; expected ratio = 0.0001obtained abs = 8.24009; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00105 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.672700e+05 Mflops = 22.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0148675; expected ratio = 1e-07obtained abs = 2.2012e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105008; expected ratio = 0.0001obtained abs = 2.77252; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000986099 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00519215; expected ratio = 1e-07obtained abs = 7.72445e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00351643; expected ratio = 0.0001obtained abs = 0.926042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00105095 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00197126; expected ratio = 1e-07obtained abs = 2.93745e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00124771; expected ratio = 0.0001obtained abs = 0.328289; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00103688 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.715740e+05 Mflops = 22.29 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000900322; expected ratio = 1e-07obtained abs = 1.34235e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000527254; expected ratio = 0.0001obtained abs = 0.138688; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000986099 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.715740e+05 Mflops = 11.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000516491; expected ratio = 1e-07obtained abs = 7.70223e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000292964; expected ratio = 0.0001obtained abs = 0.0770549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000983 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000346182; expected ratio = 1e-07obtained abs = 5.16285e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000200802; expected ratio = 0.0001obtained abs = 0.052815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00100613 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000251399; expected ratio = 1e-07obtained abs = 3.74939e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000152333; expected ratio = 0.0001obtained abs = 0.0400678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962973 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.715740e+05 Mflops = 22.29 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191247; expected ratio = 1e-07obtained abs = 2.8523e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000121171; expected ratio = 0.0001obtained abs = 0.0318724; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00097394 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.715740e+05 Mflops = 11.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000150368; expected ratio = 1e-07obtained abs = 2.24264e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.88365e-05; expected ratio = 0.0001obtained abs = 0.0259984; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000979185 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000121293; expected ratio = 1e-07obtained abs = 1.80901e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.18187e-05; expected ratio = 0.0001obtained abs = 0.0215226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000963926 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.98296e-05; expected ratio = 1e-07obtained abs = 1.4889e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.83847e-05; expected ratio = 0.0001obtained abs = 0.0179892; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000965834 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.3468e-05; expected ratio = 1e-07obtained abs = 1.24487e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.756e-05; expected ratio = 0.0001obtained abs = 0.015142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.0010221 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.715740e+05 Mflops = 22.29 -Solve time = 0.02 -Solve flops = 2.478200e+04 Mflops = 1.49 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.06506e-05; expected ratio = 1e-07obtained abs = 1.05371e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.87299e-05; expected ratio = 0.0001obtained abs = 0.0128194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000971079 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.03793e-05; expected ratio = 1e-07obtained abs = 9.0052e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.14679e-05; expected ratio = 0.0001obtained abs = 0.0109091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.08 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.08 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102806 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.463600e+04 Mflops = 1.48 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.216048; expected ratio = 1e-07obtained abs = 0.000410818; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0883545; expected ratio = 0.0001obtained abs = 24.6835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000965118 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0653026; expected ratio = 1e-07obtained abs = 0.000132809; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0707154; expected ratio = 0.0001obtained abs = 18.9133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00103617 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0171861; expected ratio = 1e-07obtained abs = 3.55475e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018153; expected ratio = 0.0001obtained abs = 4.79509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00101495 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0045463; expected ratio = 1e-07obtained abs = 9.44316e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0044773; expected ratio = 0.0001obtained abs = 1.17868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000978947 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.684660e+05 Mflops = 22.11 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00134667; expected ratio = 1e-07obtained abs = 2.8002e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118577; expected ratio = 0.0001obtained abs = 0.311878; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000984907 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.684660e+05 Mflops = 22.11 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000515756; expected ratio = 1e-07obtained abs = 1.07274e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000399175; expected ratio = 0.0001obtained abs = 0.104965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102806 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000263683; expected ratio = 1e-07obtained abs = 5.4849e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000194782; expected ratio = 0.0001obtained abs = 0.051216; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00104499 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000159727; expected ratio = 1e-07obtained abs = 3.32259e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000122177; expected ratio = 0.0001obtained abs = 0.0321253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102305 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.684660e+05 Mflops = 22.11 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000105982; expected ratio = 1e-07obtained abs = 2.20462e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.65047e-05; expected ratio = 0.0001obtained abs = 0.0227459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000968933 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.684660e+05 Mflops = 22.11 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.52236e-05; expected ratio = 1e-07obtained abs = 1.5648e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.54107e-05; expected ratio = 0.0001obtained abs = 0.0171997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000978947 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.6541e-05; expected ratio = 1e-07obtained abs = 1.17617e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.13661e-05; expected ratio = 0.0001obtained abs = 0.0135068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.0009799 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.45304e-05; expected ratio = 1e-07obtained abs = 9.26322e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.12295e-05; expected ratio = 0.0001obtained abs = 0.0108415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.09 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.09 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000982046 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.17974; expected ratio = 1e-07obtained abs = 0.000455677; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0711562; expected ratio = 0.0001obtained abs = 19.6403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102091 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0401801; expected ratio = 1e-07obtained abs = 0.000106087; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0608117; expected ratio = 0.0001obtained abs = 16.1635; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00103116 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.661580e+05 Mflops = 21.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00820655; expected ratio = 1e-07obtained abs = 2.1838e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116221; expected ratio = 0.0001obtained abs = 3.06353; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000990868 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.661580e+05 Mflops = 10.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00181554; expected ratio = 1e-07obtained abs = 4.83871e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00228645; expected ratio = 0.0001obtained abs = 0.601633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102091 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000526294; expected ratio = 1e-07obtained abs = 1.4031e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000550942; expected ratio = 0.0001obtained abs = 0.144916; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00101089 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000231744; expected ratio = 1e-07obtained abs = 6.17876e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000219459; expected ratio = 0.0001obtained abs = 0.0577213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102305 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.459200e+04 Mflops = 1.48 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133704; expected ratio = 1e-07obtained abs = 3.56489e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00013643; expected ratio = 0.0001obtained abs = 0.0358835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000969172 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.661580e+05 Mflops = 10.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.79969e-05; expected ratio = 1e-07obtained abs = 2.34623e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.95778e-05; expected ratio = 0.0001obtained abs = 0.0261912; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102496 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.30633e-05; expected ratio = 1e-07obtained abs = 1.68144e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.64507e-05; expected ratio = 0.0001obtained abs = 0.0201086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102806 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.80037e-05; expected ratio = 1e-07obtained abs = 1.27991e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.98801e-05; expected ratio = 0.0001obtained abs = 0.0157503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000988007 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.8051e-05; expected ratio = 1e-07obtained abs = 1.01454e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.7391e-05; expected ratio = 0.0001obtained abs = 0.0124655; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.001019 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.661580e+05 Mflops = 21.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.09674e-05; expected ratio = 1e-07obtained abs = 8.25676e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.77727e-05; expected ratio = 0.0001obtained abs = 0.00993562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.1 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000986099 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.153693; expected ratio = 1e-07obtained abs = 0.000484094; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0593548; expected ratio = 0.0001obtained abs = 16.2537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102687 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647700e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0263701; expected ratio = 1e-07obtained abs = 8.52699e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0528325; expected ratio = 0.0001obtained abs = 13.9976; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00099206 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00438578; expected ratio = 1e-07obtained abs = 1.42392e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00787425; expected ratio = 0.0001obtained abs = 2.07405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000952959 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000868003; expected ratio = 1e-07obtained abs = 2.81996e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00131321; expected ratio = 0.0001obtained abs = 0.345543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000966072 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000273281; expected ratio = 1e-07obtained abs = 8.87933e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000319634; expected ratio = 0.0001obtained abs = 0.0840913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00107908 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647700e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000139744; expected ratio = 1e-07obtained abs = 4.5406e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000157173; expected ratio = 0.0001obtained abs = 0.0413495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000967979 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647700e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.95038e-05; expected ratio = 1e-07obtained abs = 2.9082e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000110873; expected ratio = 0.0001obtained abs = 0.0291692; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00100899 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.38341e-05; expected ratio = 1e-07obtained abs = 2.07413e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.46205e-05; expected ratio = 0.0001obtained abs = 0.0222628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102997 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.83563e-05; expected ratio = 1e-07obtained abs = 1.57122e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.5782e-05; expected ratio = 0.0001obtained abs = 0.0173068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102019 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647700e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.7898e-05; expected ratio = 1e-07obtained abs = 1.2314e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.14986e-05; expected ratio = 0.0001obtained abs = 0.013549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000923157 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.647700e+05 Mflops = 10.94 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.0292e-05; expected ratio = 1e-07obtained abs = 9.84265e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.0503e-05; expected ratio = 0.0001obtained abs = 0.0106562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.11 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.11 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000982046 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.134056; expected ratio = 1e-07obtained abs = 0.000502924; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0510319; expected ratio = 0.0001obtained abs = 13.8998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00112295 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.644180e+05 Mflops = 10.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0180809; expected ratio = 1e-07obtained abs = 6.90472e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0464658; expected ratio = 0.0001obtained abs = 12.2917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000965834 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00253839; expected ratio = 1e-07obtained abs = 9.71529e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00550957; expected ratio = 0.0001obtained abs = 1.45269; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000978947 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000476965; expected ratio = 1e-07obtained abs = 1.82606e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000797341; expected ratio = 0.0001obtained abs = 0.210141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00103498 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000174087; expected ratio = 1e-07obtained abs = 6.66521e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000230542; expected ratio = 0.0001obtained abs = 0.0607586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000966072 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.644180e+05 Mflops = 21.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000102; expected ratio = 1e-07obtained abs = 3.90529e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000140062; expected ratio = 0.0001obtained abs = 0.036914; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000968933 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.06059e-05; expected ratio = 1e-07obtained abs = 2.70329e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103256; expected ratio = 0.0001obtained abs = 0.0272143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000963926 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.23935e-05; expected ratio = 1e-07obtained abs = 2.00599e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.88827e-05; expected ratio = 0.0001obtained abs = 0.0207908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000964165 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.02197e-05; expected ratio = 1e-07obtained abs = 1.53989e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.09792e-05; expected ratio = 0.0001obtained abs = 0.0160722; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000966072 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.644180e+05 Mflops = 21.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.14431e-05; expected ratio = 1e-07obtained abs = 1.20386e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.7467e-05; expected ratio = 0.0001obtained abs = 0.0125109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000972986 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.644180e+05 Mflops = 21.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.48586e-05; expected ratio = 1e-07obtained abs = 9.51761e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.71422e-05; expected ratio = 0.0001obtained abs = 0.00978968; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.12 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.12 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00105 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.118696; expected ratio = 1e-07obtained abs = 0.000515585; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.044575; expected ratio = 0.0001obtained abs = 12.107; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102496 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.625660e+05 Mflops = 10.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0127835; expected ratio = 1e-07obtained abs = 5.62172e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0412497; expected ratio = 0.0001obtained abs = 10.9167; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000983 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00155765; expected ratio = 1e-07obtained abs = 6.85893e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00404625; expected ratio = 0.0001obtained abs = 1.06748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00096488 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000298449; expected ratio = 1e-07obtained abs = 1.31438e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000551429; expected ratio = 0.0001obtained abs = 0.145422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000965118 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.625660e+05 Mflops = 21.75 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000130887; expected ratio = 1e-07obtained abs = 5.76443e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000170784; expected ratio = 0.0001obtained abs = 0.0450375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00100708 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.625660e+05 Mflops = 10.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.46296e-05; expected ratio = 1e-07obtained abs = 3.72721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000117026; expected ratio = 0.0001obtained abs = 0.0308614; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00103283 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.09044e-05; expected ratio = 1e-07obtained abs = 2.68232e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.01293e-05; expected ratio = 0.0001obtained abs = 0.0237686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00102806 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.56198e-05; expected ratio = 1e-07obtained abs = 2.00916e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.99534e-05; expected ratio = 0.0001obtained abs = 0.0184481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00101495 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.48165e-05; expected ratio = 1e-07obtained abs = 1.53337e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.44696e-05; expected ratio = 0.0001obtained abs = 0.0143648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00104189 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.625660e+05 Mflops = 10.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.68544e-05; expected ratio = 1e-07obtained abs = 1.1827e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.2567e-05; expected ratio = 0.0001obtained abs = 0.0112259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.001055 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.08632e-05; expected ratio = 1e-07obtained abs = 9.18843e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.33827e-05; expected ratio = 0.0001obtained abs = 0.00880383; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.13 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.13 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107694 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.631520e+05 Mflops = 21.79 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.102602; expected ratio = 1e-07obtained abs = 0.00050258; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104682; expected ratio = 0.0001obtained abs = 28.4674; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000996113 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00876574; expected ratio = 1e-07obtained abs = 4.32958e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0345866; expected ratio = 0.0001obtained abs = 9.2142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00101399 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00106289; expected ratio = 1e-07obtained abs = 5.25396e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00296134; expected ratio = 0.0001obtained abs = 0.787259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00109816 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000270733; expected ratio = 1e-07obtained abs = 1.33839e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000465436; expected ratio = 0.0001obtained abs = 0.123704; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000982046 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000127323; expected ratio = 1e-07obtained abs = 6.29441e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000189618; expected ratio = 0.0001obtained abs = 0.0503951; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000971794 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.55339e-05; expected ratio = 1e-07obtained abs = 3.73414e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126566; expected ratio = 0.0001obtained abs = 0.0336375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000963926 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.05337e-05; expected ratio = 1e-07obtained abs = 2.49822e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.12862e-05; expected ratio = 0.0001obtained abs = 0.024261; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000977039 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.61131e-05; expected ratio = 1e-07obtained abs = 1.78531e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.75406e-05; expected ratio = 0.0001obtained abs = 0.0179501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00101805 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.67261e-05; expected ratio = 1e-07obtained abs = 1.32125e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.08814e-05; expected ratio = 0.0001obtained abs = 0.0135226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00108695 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.01823e-05; expected ratio = 1e-07obtained abs = 9.97744e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.89002e-05; expected ratio = 0.0001obtained abs = 0.0103384; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.14 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.14 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00109076 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.088952; expected ratio = 1e-07obtained abs = 0.000482124; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0457042; expected ratio = 0.0001obtained abs = 12.5374; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000966787 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.647520e+05 Mflops = 10.94 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00681511; expected ratio = 1e-07obtained abs = 3.71575e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.030695; expected ratio = 0.0001obtained abs = 8.2788; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107503 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00125941; expected ratio = 1e-07obtained abs = 6.87025e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00260539; expected ratio = 0.0001obtained abs = 0.701608; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000972986 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000472845; expected ratio = 1e-07obtained abs = 2.57962e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000604578; expected ratio = 0.0001obtained abs = 0.162774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107908 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.460000e+04 Mflops = 1.48 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00022082; expected ratio = 1e-07obtained abs = 1.20471e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000290133; expected ratio = 0.0001obtained abs = 0.0781093; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00109696 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.02 -Solve flops = 2.460000e+04 Mflops = 1.48 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000122527; expected ratio = 1e-07obtained abs = 6.68467e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000185452; expected ratio = 0.0001obtained abs = 0.0499257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00108409 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.05955e-05; expected ratio = 1e-07obtained abs = 4.39702e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00013178; expected ratio = 0.0001obtained abs = 0.0354762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000981092 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.95231e-05; expected ratio = 1e-07obtained abs = 3.24738e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.92996e-05; expected ratio = 0.0001obtained abs = 0.0267321; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00109005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.68004e-05; expected ratio = 1e-07obtained abs = 2.55327e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.82617e-05; expected ratio = 0.0001obtained abs = 0.0210686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00104499 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.647520e+05 Mflops = 10.94 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.80689e-05; expected ratio = 1e-07obtained abs = 2.07691e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.39938e-05; expected ratio = 0.0001obtained abs = 0.0172277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000980854 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.16157e-05; expected ratio = 1e-07obtained abs = 1.72484e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.38245e-05; expected ratio = 0.0001obtained abs = 0.0144902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107408 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.66296e-05; expected ratio = 1e-07obtained abs = 1.45282e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.61749e-05; expected ratio = 0.0001obtained abs = 0.0124309; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00156713 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.26608e-05; expected ratio = 1e-07obtained abs = 1.2363e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.01257e-05; expected ratio = 0.0001obtained abs = 0.0108025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000971079 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.647520e+05 Mflops = 10.94 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.9433e-05; expected ratio = 1e-07obtained abs = 1.0602e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.51476e-05; expected ratio = 0.0001obtained abs = 0.00946243; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000981092 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.67645e-05; expected ratio = 1e-07obtained abs = 9.14614e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.09337e-05; expected ratio = 0.0001obtained abs = 0.00832806; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.15 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.15 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000988007 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.588320e+05 Mflops = 21.53 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.079838; expected ratio = 1e-07obtained abs = 0.000472481; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0486908; expected ratio = 0.0001obtained abs = 13.4333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00097394 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00672471; expected ratio = 1e-07obtained abs = 3.99795e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0262028; expected ratio = 0.0001obtained abs = 7.13838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00095582 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0018086; expected ratio = 1e-07obtained abs = 1.07569e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00222453; expected ratio = 0.0001obtained abs = 0.605546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000969172 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00070754; expected ratio = 1e-07obtained abs = 4.20842e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000673565; expected ratio = 0.0001obtained abs = 0.18335; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000978947 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.610360e+05 Mflops = 21.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000320884; expected ratio = 1e-07obtained abs = 1.90862e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000327557; expected ratio = 0.0001obtained abs = 0.0891637; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000969887 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000176298; expected ratio = 1e-07obtained abs = 1.04863e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00021167; expected ratio = 0.0001obtained abs = 0.0576182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.001019 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000116921; expected ratio = 1e-07obtained abs = 6.95447e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000159376; expected ratio = 0.0001obtained abs = 0.0433836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000969172 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.71283e-05; expected ratio = 1e-07obtained abs = 5.18241e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000129257; expected ratio = 0.0001obtained abs = 0.0351855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000955105 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.447000e+04 Mflops = 1.47 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.889e-05; expected ratio = 1e-07obtained abs = 4.0976e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00010964; expected ratio = 0.0001obtained abs = 0.029846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000948906 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.610360e+05 Mflops = 10.83 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.62597e-05; expected ratio = 1e-07obtained abs = 3.34634e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.56205e-05; expected ratio = 0.0001obtained abs = 0.0260303; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000936031 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.68971e-05; expected ratio = 1e-07obtained abs = 2.78944e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.46942e-05; expected ratio = 0.0001obtained abs = 0.0230565; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106716 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.96636e-05; expected ratio = 1e-07obtained abs = 2.35919e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.55923e-05; expected ratio = 0.0001obtained abs = 0.0205792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107598 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.610360e+05 Mflops = 21.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.39134e-05; expected ratio = 1e-07obtained abs = 2.01717e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.7694e-05; expected ratio = 0.0001obtained abs = 0.0184295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106907 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.610360e+05 Mflops = 10.83 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.92439e-05; expected ratio = 1e-07obtained abs = 1.73943e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.06928e-05; expected ratio = 0.0001obtained abs = 0.0165238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000939131 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.5388e-05; expected ratio = 1e-07obtained abs = 1.51008e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.44265e-05; expected ratio = 0.0001obtained abs = 0.0148181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107408 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.21603e-05; expected ratio = 1e-07obtained abs = 1.3181e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.87974e-05; expected ratio = 0.0001obtained abs = 0.0132858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106692 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.94284e-05; expected ratio = 1e-07obtained abs = 1.1556e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.3736e-05; expected ratio = 0.0001obtained abs = 0.011908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00103402 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.610360e+05 Mflops = 21.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.70943e-05; expected ratio = 1e-07obtained abs = 1.01677e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.91862e-05; expected ratio = 0.0001obtained abs = 0.0106694; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000936031 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.50848e-05; expected ratio = 1e-07obtained abs = 8.97244e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.5099e-05; expected ratio = 0.0001obtained abs = 0.00955672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.16 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.16 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000941038 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.566280e+05 Mflops = 10.70 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0726013; expected ratio = 1e-07obtained abs = 0.000465115; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0262905; expected ratio = 0.0001obtained abs = 7.18061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00108504 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.581400e+05 Mflops = 10.74 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00498319; expected ratio = 1e-07obtained abs = 3.20306e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0244707; expected ratio = 0.0001obtained abs = 6.59593; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00108218 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00119607; expected ratio = 1e-07obtained abs = 7.69019e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00170204; expected ratio = 0.0001obtained abs = 0.458351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00108886 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000449949; expected ratio = 1e-07obtained abs = 2.89307e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000462168; expected ratio = 0.0001obtained abs = 0.12444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.001091 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.566280e+05 Mflops = 21.40 -Solve time = 0.02 -Solve flops = 2.431800e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000213771; expected ratio = 1e-07obtained abs = 1.37451e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000234282; expected ratio = 0.0001obtained abs = 0.0630748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000935078 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.566280e+05 Mflops = 10.70 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000128172; expected ratio = 1e-07obtained abs = 8.24121e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000158833; expected ratio = 0.0001obtained abs = 0.0427586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106907 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.88395e-05; expected ratio = 1e-07obtained abs = 5.7122e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000118867; expected ratio = 0.0001obtained abs = 0.0319976; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00101995 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.56513e-05; expected ratio = 1e-07obtained abs = 4.22124e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.23936e-05; expected ratio = 0.0001obtained abs = 0.02487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000929117 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.99936e-05; expected ratio = 1e-07obtained abs = 3.21448e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.38094e-05; expected ratio = 0.0001obtained abs = 0.0198668; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000940084 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.566280e+05 Mflops = 21.40 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.87868e-05; expected ratio = 1e-07obtained abs = 2.49391e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.03781e-05; expected ratio = 0.0001obtained abs = 0.0162511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000935078 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.05432e-05; expected ratio = 1e-07obtained abs = 1.96386e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.03706e-05; expected ratio = 0.0001obtained abs = 0.0135572; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106192 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.4381e-05; expected ratio = 1e-07obtained abs = 1.56764e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.26746e-05; expected ratio = 0.0001obtained abs = 0.0114856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.001055 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.97198e-05; expected ratio = 1e-07obtained abs = 1.26794e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.65799e-05; expected ratio = 0.0001obtained abs = 0.00984506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000930071 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.566280e+05 Mflops = 21.40 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.61562e-05; expected ratio = 1e-07obtained abs = 1.03881e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.16309e-05; expected ratio = 0.0001obtained abs = 0.00851295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107694 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.34016e-05; expected ratio = 1e-07obtained abs = 8.61694e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.75294e-05; expected ratio = 0.0001obtained abs = 0.00740902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.17 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.17 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000931025 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.537280e+05 Mflops = 21.22 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0668691; expected ratio = 1e-07obtained abs = 0.000460562; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0287218; expected ratio = 0.0001obtained abs = 7.89476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.0010519 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.559320e+05 Mflops = 10.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.003143; expected ratio = 1e-07obtained abs = 2.16985e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234887; expected ratio = 0.0001obtained abs = 6.36728; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000924826 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000512007; expected ratio = 1e-07obtained abs = 3.53537e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00138533; expected ratio = 0.0001obtained abs = 0.375137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107789 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000225086; expected ratio = 1e-07obtained abs = 1.55422e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000293958; expected ratio = 0.0001obtained abs = 0.0795866; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000921965 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000135505; expected ratio = 1e-07obtained abs = 9.35663e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000158257; expected ratio = 0.0001obtained abs = 0.0428434; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000954866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.559320e+05 Mflops = 21.36 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.13806e-05; expected ratio = 1e-07obtained abs = 6.30984e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000105038; expected ratio = 0.0001obtained abs = 0.0284345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000922203 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.48536e-05; expected ratio = 1e-07obtained abs = 4.47814e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.39983e-05; expected ratio = 0.0001obtained abs = 0.0200311; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106502 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.7254e-05; expected ratio = 1e-07obtained abs = 3.26288e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.44929e-05; expected ratio = 0.0001obtained abs = 0.0147507; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000919819 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.50073e-05; expected ratio = 1e-07obtained abs = 2.41725e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.17395e-05; expected ratio = 0.0001obtained abs = 0.0112982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000925064 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.559320e+05 Mflops = 10.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.62683e-05; expected ratio = 1e-07obtained abs = 1.81382e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.30532e-05; expected ratio = 0.0001obtained abs = 0.00894686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.0010469 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.559320e+05 Mflops = 21.36 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.99388e-05; expected ratio = 1e-07obtained abs = 1.37677e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.68806e-05; expected ratio = 0.0001obtained abs = 0.00727596; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106001 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.53093e-05; expected ratio = 1e-07obtained abs = 1.0571e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.23147e-05; expected ratio = 0.0001obtained abs = 0.00604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000915051 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.18989e-05; expected ratio = 1e-07obtained abs = 8.21615e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.88157e-05; expected ratio = 0.0001obtained abs = 0.0050929; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.18 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.18 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107503 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0619755; expected ratio = 1e-07obtained abs = 0.000456085; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0233768; expected ratio = 0.0001obtained abs = 6.4114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00247249; expected ratio = 1e-07obtained abs = 1.82263e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0220563; expected ratio = 0.0001obtained abs = 5.96963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000929117 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000387398; expected ratio = 1e-07obtained abs = 2.85609e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00120987; expected ratio = 0.0001obtained abs = 0.327146; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000935793 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.537280e+05 Mflops = 21.22 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000179064; expected ratio = 1e-07obtained abs = 1.32016e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000250658; expected ratio = 0.0001obtained abs = 0.0677682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107718 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000105198; expected ratio = 1e-07obtained abs = 7.7557e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134471; expected ratio = 0.0001obtained abs = 0.0363545; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000920057 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.75586e-05; expected ratio = 1e-07obtained abs = 4.98076e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.71147e-05; expected ratio = 0.0001obtained abs = 0.0235513; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000927925 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.58943e-05; expected ratio = 1e-07obtained abs = 3.38355e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.99439e-05; expected ratio = 0.0001obtained abs = 0.0162057; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00104809 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.537280e+05 Mflops = 10.61 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.23965e-05; expected ratio = 1e-07obtained abs = 2.38843e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.3802e-05; expected ratio = 0.0001obtained abs = 0.0118418; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000936031 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.537280e+05 Mflops = 10.61 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.35386e-05; expected ratio = 1e-07obtained abs = 1.73538e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.39113e-05; expected ratio = 0.0001obtained abs = 0.00916789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000924826 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.75233e-05; expected ratio = 1e-07obtained abs = 1.2919e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.74965e-05; expected ratio = 0.0001obtained abs = 0.00743369; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000916958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.33404e-05; expected ratio = 1e-07obtained abs = 9.83515e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.30167e-05; expected ratio = 0.0001obtained abs = 0.00622262; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.19 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.19 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000929832 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0577402; expected ratio = 1e-07obtained abs = 0.000451666; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0233957; expected ratio = 0.0001obtained abs = 6.41925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106287 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00205787; expected ratio = 1e-07obtained abs = 1.61168e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0206753; expected ratio = 0.0001obtained abs = 5.60237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106192 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000336555; expected ratio = 1e-07obtained abs = 2.63606e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00107195; expected ratio = 0.0001obtained abs = 0.290225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000923157 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000157271; expected ratio = 1e-07obtained abs = 1.23182e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000225067; expected ratio = 0.0001obtained abs = 0.0609289; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00107193 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.03644e-05; expected ratio = 1e-07obtained abs = 7.07775e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000124665; expected ratio = 0.0001obtained abs = 0.033748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00106978 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.64103e-05; expected ratio = 1e-07obtained abs = 4.4183e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.32152e-05; expected ratio = 0.0001obtained abs = 0.0225271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000920057 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.73238e-05; expected ratio = 1e-07obtained abs = 2.92336e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.92927e-05; expected ratio = 0.0001obtained abs = 0.0160511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00103593 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.02 -Solve flops = 2.428400e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.58564e-05; expected ratio = 1e-07obtained abs = 2.02518e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.49362e-05; expected ratio = 0.0001obtained abs = 0.0121648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.86413e-05; expected ratio = 1e-07obtained abs = 1.46007e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.58854e-05; expected ratio = 0.0001obtained abs = 0.00971471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000522137 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.3944e-05; expected ratio = 1e-07obtained abs = 1.09215e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.97467e-05; expected ratio = 0.0001obtained abs = 0.00805295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.07963e-05; expected ratio = 1e-07obtained abs = 8.45611e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.52511e-05; expected ratio = 0.0001obtained abs = 0.00683595; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.2 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000529051 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0539346; expected ratio = 1e-07obtained abs = 0.00044642; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0214648; expected ratio = 0.0001obtained abs = 5.88552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000518799 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00176814; expected ratio = 1e-07obtained abs = 1.46469e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0193157; expected ratio = 0.0001obtained abs = 5.23536; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00052309 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000308188; expected ratio = 1e-07obtained abs = 2.55315e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000929269; expected ratio = 0.0001obtained abs = 0.251697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00052309 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00014671; expected ratio = 1e-07obtained abs = 1.2154e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000215553; expected ratio = 0.0001obtained abs = 0.0583795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.44419e-05; expected ratio = 1e-07obtained abs = 6.99546e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134896; expected ratio = 0.0001obtained abs = 0.0365349; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.32568e-05; expected ratio = 1e-07obtained abs = 4.41197e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.87955e-05; expected ratio = 0.0001obtained abs = 0.026758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.61325e-05; expected ratio = 1e-07obtained abs = 2.99333e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.68227e-05; expected ratio = 0.0001obtained abs = 0.0208072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.61407e-05; expected ratio = 1e-07obtained abs = 2.16558e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.26245e-05; expected ratio = 0.0001obtained abs = 0.016962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.00118e-05; expected ratio = 1e-07obtained abs = 1.65784e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.2733e-05; expected ratio = 0.0001obtained abs = 0.0142832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.60539e-05; expected ratio = 1e-07obtained abs = 1.32995e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.53115e-05; expected ratio = 0.0001obtained abs = 0.0122732; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000521898 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.33467e-05; expected ratio = 1e-07obtained abs = 1.10568e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.94167e-05; expected ratio = 0.0001obtained abs = 0.0106767; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000536919 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.13802e-05; expected ratio = 1e-07obtained abs = 9.42771e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.45532e-05; expected ratio = 0.0001obtained abs = 0.00935947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.21 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.21 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0505064; expected ratio = 1e-07obtained abs = 0.000440565; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0205417; expected ratio = 0.0001obtained abs = 5.63132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000528812 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00156088; expected ratio = 1e-07obtained abs = 1.36224e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0180713; expected ratio = 0.0001obtained abs = 4.90152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000287936; expected ratio = 1e-07obtained abs = 2.51307e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000806445; expected ratio = 0.0001obtained abs = 0.21861; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000517845 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000139021; expected ratio = 1e-07obtained abs = 1.21336e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000211662; expected ratio = 0.0001obtained abs = 0.0573746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.99405e-05; expected ratio = 1e-07obtained abs = 6.97709e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000142725; expected ratio = 0.0001obtained abs = 0.0386889; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.0583e-05; expected ratio = 1e-07obtained abs = 4.4148e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00010851; expected ratio = 0.0001obtained abs = 0.029415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.46956e-05; expected ratio = 1e-07obtained abs = 3.02817e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.66429e-05; expected ratio = 0.0001obtained abs = 0.023488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.55843e-05; expected ratio = 1e-07obtained abs = 2.23295e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.18771e-05; expected ratio = 0.0001obtained abs = 0.0194856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.00648e-05; expected ratio = 1e-07obtained abs = 1.75121e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.1195e-05; expected ratio = 0.0001obtained abs = 0.0165902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000529051 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.64994e-05; expected ratio = 1e-07obtained abs = 1.44004e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.29732e-05; expected ratio = 0.0001obtained abs = 0.0143615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.40217e-05; expected ratio = 1e-07obtained abs = 1.22379e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.63465e-05; expected ratio = 0.0001obtained abs = 0.0125652; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.21719e-05; expected ratio = 1e-07obtained abs = 1.06234e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.0835e-05; expected ratio = 0.0001obtained abs = 0.0110712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.07056e-05; expected ratio = 1e-07obtained abs = 9.34364e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.61536e-05; expected ratio = 0.0001obtained abs = 0.00980211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.22 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.22 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000522137 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0473851; expected ratio = 1e-07obtained abs = 0.000434034; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.019334; expected ratio = 0.0001obtained abs = 5.29944; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00141766; expected ratio = 1e-07obtained abs = 1.29889e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0169182; expected ratio = 0.0001obtained abs = 4.59211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000537872 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.02 -Solve flops = 2.428400e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000274755; expected ratio = 1e-07obtained abs = 2.51747e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000702984; expected ratio = 0.0001obtained abs = 0.190723; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133866; expected ratio = 1e-07obtained abs = 1.22656e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000217947; expected ratio = 0.0001obtained abs = 0.0591296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.68681e-05; expected ratio = 1e-07obtained abs = 7.04307e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000154184; expected ratio = 0.0001obtained abs = 0.041832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.88555e-05; expected ratio = 1e-07obtained abs = 4.4764e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000119833; expected ratio = 0.0001obtained abs = 0.0325135; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.39297e-05; expected ratio = 1e-07obtained abs = 3.10881e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.73072e-05; expected ratio = 0.0001obtained abs = 0.0264026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.55001e-05; expected ratio = 1e-07obtained abs = 2.33645e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.17382e-05; expected ratio = 0.0001obtained abs = 0.022179; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.04326e-05; expected ratio = 1e-07obtained abs = 1.87214e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.02566e-05; expected ratio = 0.0001obtained abs = 0.0190641; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.71395e-05; expected ratio = 1e-07obtained abs = 1.57041e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.13003e-05; expected ratio = 0.0001obtained abs = 0.0166343; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.48071e-05; expected ratio = 1e-07obtained abs = 1.3567e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.40149e-05; expected ratio = 0.0001obtained abs = 0.0146577; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000521898 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.30205e-05; expected ratio = 1e-07obtained abs = 1.19301e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.79119e-05; expected ratio = 0.0001obtained abs = 0.0130019; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.15678e-05; expected ratio = 1e-07obtained abs = 1.0599e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.26938e-05; expected ratio = 0.0001obtained abs = 0.0115861; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.0338e-05; expected ratio = 1e-07obtained abs = 9.47222e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.81679e-05; expected ratio = 0.0001obtained abs = 0.010358; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.23 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.23 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000522137 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0445298; expected ratio = 1e-07obtained abs = 0.000426905; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0184105; expected ratio = 0.0001obtained abs = 5.04613; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00132007; expected ratio = 1e-07obtained abs = 1.26564e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0158539; expected ratio = 0.0001obtained abs = 4.30672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00056982 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000265972; expected ratio = 1e-07obtained abs = 2.55016e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000617299; expected ratio = 0.0001obtained abs = 0.167629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000529051 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000129946; expected ratio = 1e-07obtained abs = 1.24593e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000226807; expected ratio = 0.0001obtained abs = 0.0615905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.4135e-05; expected ratio = 1e-07obtained abs = 7.10809e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000163669; expected ratio = 0.0001obtained abs = 0.0444472; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.69744e-05; expected ratio = 1e-07obtained abs = 4.50392e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000128282; expected ratio = 0.0001obtained abs = 0.0348389; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.2694e-05; expected ratio = 1e-07obtained abs = 3.1347e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104975; expected ratio = 0.0001obtained abs = 0.0285103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.47472e-05; expected ratio = 1e-07obtained abs = 2.37276e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.87868e-05; expected ratio = 0.0001obtained abs = 0.0241148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.00262e-05; expected ratio = 1e-07obtained abs = 1.92011e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.68025e-05; expected ratio = 0.0001obtained abs = 0.0208605; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.69708e-05; expected ratio = 1e-07obtained abs = 1.62716e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.74276e-05; expected ratio = 0.0001obtained abs = 0.0183148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.47966e-05; expected ratio = 1e-07obtained abs = 1.4187e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.97793e-05; expected ratio = 0.0001obtained abs = 0.0162378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.31141e-05; expected ratio = 1e-07obtained abs = 1.25738e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.33478e-05; expected ratio = 0.0001obtained abs = 0.0144912; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000540018 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17296e-05; expected ratio = 1e-07obtained abs = 1.12464e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.78226e-05; expected ratio = 0.0001obtained abs = 0.0129906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000521183 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.05445e-05; expected ratio = 1e-07obtained abs = 1.011e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.3004e-05; expected ratio = 0.0001obtained abs = 0.0116819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.50585e-06; expected ratio = 1e-07obtained abs = 9.11419e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.87566e-05; expected ratio = 0.0001obtained abs = 0.0105283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.24 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.24 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0419013; expected ratio = 1e-07obtained abs = 0.000419195; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0174814; expected ratio = 0.0001obtained abs = 4.79194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00125501; expected ratio = 1e-07obtained abs = 1.25546e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0148651; expected ratio = 0.0001obtained abs = 4.04179; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000522137 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.528920e+05 Mflops = 21.17 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000260239; expected ratio = 1e-07obtained abs = 2.60342e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000548896; expected ratio = 0.0001obtained abs = 0.149202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000521183 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.528920e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00012686; expected ratio = 1e-07obtained abs = 1.2691e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000237637; expected ratio = 0.0001obtained abs = 0.0645969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000566006 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.17126e-05; expected ratio = 1e-07obtained abs = 7.17406e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000172403; expected ratio = 0.0001obtained abs = 0.046867; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000516176 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.51318e-05; expected ratio = 1e-07obtained abs = 4.51494e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000135648; expected ratio = 0.0001obtained abs = 0.0368774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.13212e-05; expected ratio = 1e-07obtained abs = 3.13333e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000111638; expected ratio = 0.0001obtained abs = 0.0303514; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000663996 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.37464e-05; expected ratio = 1e-07obtained abs = 2.37556e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.502e-05; expected ratio = 0.0001obtained abs = 0.0258345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.93118e-05; expected ratio = 1e-07obtained abs = 1.93193e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.27305e-05; expected ratio = 0.0001obtained abs = 0.0224941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.64701e-05; expected ratio = 1e-07obtained abs = 1.64764e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.31078e-05; expected ratio = 0.0001obtained abs = 0.0198784; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.44527e-05; expected ratio = 1e-07obtained abs = 1.44583e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.52333e-05; expected ratio = 0.0001obtained abs = 0.0177379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000522137 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.28856e-05; expected ratio = 1e-07obtained abs = 1.28906e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.85796e-05; expected ratio = 0.0001obtained abs = 0.0159291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.15873e-05; expected ratio = 1e-07obtained abs = 1.15918e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.28291e-05; expected ratio = 0.0001obtained abs = 0.0143658; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.04676e-05; expected ratio = 1e-07obtained abs = 1.04717e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.77807e-05; expected ratio = 0.0001obtained abs = 0.0129933; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00052619 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.47965e-06; expected ratio = 1e-07obtained abs = 9.48331e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.33005e-05; expected ratio = 0.0001obtained abs = 0.0117752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.25 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.25 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0394705; expected ratio = 1e-07obtained abs = 0.000410948; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0166708; expected ratio = 0.0001obtained abs = 4.57039; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000516176 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00121168; expected ratio = 1e-07obtained abs = 1.2613e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0139452; expected ratio = 0.0001obtained abs = 3.79521; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.528920e+05 Mflops = 10.59 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000256682; expected ratio = 1e-07obtained abs = 2.67201e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000495989; expected ratio = 0.0001obtained abs = 0.134956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.528920e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000124359; expected ratio = 1e-07obtained abs = 1.29455e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000248545; expected ratio = 0.0001obtained abs = 0.0676309; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.94859e-05; expected ratio = 1e-07obtained abs = 7.23331e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000179801; expected ratio = 0.0001obtained abs = 0.0489282; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.32518e-05; expected ratio = 1e-07obtained abs = 4.5024e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000141555; expected ratio = 0.0001obtained abs = 0.0385228; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.420800e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.97445e-05; expected ratio = 1e-07obtained abs = 3.09633e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000116922; expected ratio = 0.0001obtained abs = 0.031821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000527143 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.528920e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.24333e-05; expected ratio = 1e-07obtained abs = 2.33525e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100013; expected ratio = 0.0001obtained abs = 0.0272203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000521898 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.82273e-05; expected ratio = 1e-07obtained abs = 1.89742e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.75616e-05; expected ratio = 0.0001obtained abs = 0.0238325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.55775e-05; expected ratio = 1e-07obtained abs = 1.62157e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.78186e-05; expected ratio = 0.0001obtained abs = 0.0211815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.37168e-05; expected ratio = 1e-07obtained abs = 1.42788e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.98258e-05; expected ratio = 0.0001obtained abs = 0.0190065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.528920e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.22765e-05; expected ratio = 1e-07obtained abs = 1.27795e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.30403e-05; expected ratio = 0.0001obtained abs = 0.0171601; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.528920e+05 Mflops = 21.17 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.10816e-05; expected ratio = 1e-07obtained abs = 1.15356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.71412e-05; expected ratio = 0.0001obtained abs = 0.0155547; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000516176 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.00472e-05; expected ratio = 1e-07obtained abs = 1.04588e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.19293e-05; expected ratio = 0.0001obtained abs = 0.0141364; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.13043e-06; expected ratio = 1e-07obtained abs = 9.50452e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.72745e-05; expected ratio = 0.0001obtained abs = 0.0128695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.26 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.26 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0372122; expected ratio = 1e-07obtained abs = 0.000402192; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0159015; expected ratio = 0.0001obtained abs = 4.36047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000521898 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00118253; expected ratio = 1e-07obtained abs = 1.27772e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0130868; expected ratio = 0.0001obtained abs = 3.5651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000517845 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000254627; expected ratio = 1e-07obtained abs = 2.75131e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000458334; expected ratio = 0.0001obtained abs = 0.124841; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.525800e+05 Mflops = 10.58 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000122294; expected ratio = 1e-07obtained abs = 1.32142e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000259771; expected ratio = 0.0001obtained abs = 0.0707607; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.74956e-05; expected ratio = 1e-07obtained abs = 7.29304e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000186856; expected ratio = 0.0001obtained abs = 0.0509026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.14817e-05; expected ratio = 1e-07obtained abs = 4.48218e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00014712; expected ratio = 0.0001obtained abs = 0.0400803; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.525800e+05 Mflops = 21.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.81745e-05; expected ratio = 1e-07obtained abs = 3.04431e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000121933; expected ratio = 0.0001obtained abs = 0.0332206; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.10493e-05; expected ratio = 1e-07obtained abs = 2.27442e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104793; expected ratio = 0.0001obtained abs = 0.0285523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.70204e-05; expected ratio = 1e-07obtained abs = 1.83909e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.22165e-05; expected ratio = 0.0001obtained abs = 0.0251267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.45314e-05; expected ratio = 1e-07obtained abs = 1.57014e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.23657e-05; expected ratio = 0.0001obtained abs = 0.0224436; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.28096e-05; expected ratio = 1e-07obtained abs = 1.3841e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.42502e-05; expected ratio = 0.0001obtained abs = 0.020233; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000631094 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.14868e-05; expected ratio = 1e-07obtained abs = 1.24117e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.73193e-05; expected ratio = 0.0001obtained abs = 0.0183449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.03909e-05; expected ratio = 1e-07obtained abs = 1.12276e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.12538e-05; expected ratio = 0.0001obtained abs = 0.0166926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.44086e-06; expected ratio = 1e-07obtained abs = 1.0201e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.586e-05; expected ratio = 0.0001obtained abs = 0.0152231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.59672e-06; expected ratio = 1e-07obtained abs = 9.2889e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.10135e-05; expected ratio = 0.0001obtained abs = 0.0139027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.27 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.27 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0351057; expected ratio = 1e-07obtained abs = 0.000392961; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.015209; expected ratio = 0.0001obtained abs = 4.17164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00116222; expected ratio = 1e-07obtained abs = 1.30047e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122853; expected ratio = 0.0001obtained abs = 3.35008; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000253586; expected ratio = 1e-07obtained abs = 2.83761e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000434372; expected ratio = 0.0001obtained abs = 0.118437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.525800e+05 Mflops = 21.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000120489; expected ratio = 1e-07obtained abs = 1.34826e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000269595; expected ratio = 0.0001obtained abs = 0.0735142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.56127e-05; expected ratio = 1e-07obtained abs = 7.34198e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000192093; expected ratio = 0.0001obtained abs = 0.0523848; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000511169 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.9696e-05; expected ratio = 1e-07obtained abs = 4.44193e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000150844; expected ratio = 0.0001obtained abs = 0.0411388; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.525800e+05 Mflops = 10.58 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.64759e-05; expected ratio = 1e-07obtained abs = 2.96261e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000125142; expected ratio = 0.0001obtained abs = 0.0341313; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.94476e-05; expected ratio = 1e-07obtained abs = 2.17616e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107823; expected ratio = 0.0001obtained abs = 0.0294091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.55387e-05; expected ratio = 1e-07obtained abs = 1.73875e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.51653e-05; expected ratio = 0.0001obtained abs = 0.025958; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.31806e-05; expected ratio = 1e-07obtained abs = 1.47488e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.52432e-05; expected ratio = 0.0001obtained abs = 0.0232526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.15857e-05; expected ratio = 1e-07obtained abs = 1.29642e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.70364e-05; expected ratio = 0.0001obtained abs = 0.0210148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.03785e-05; expected ratio = 1e-07obtained abs = 1.16134e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.99895e-05; expected ratio = 0.0001obtained abs = 0.0190932; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.38554e-06; expected ratio = 1e-07obtained abs = 1.05023e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.37881e-05; expected ratio = 0.0001obtained abs = 0.017402; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.52688e-06; expected ratio = 1e-07obtained abs = 9.54144e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.82451e-05; expected ratio = 0.0001obtained abs = 0.0158903; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.28 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.28 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0773279; expected ratio = 1e-07obtained abs = 0.000890359; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.184948; expected ratio = 0.0001obtained abs = 56.4367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0124013; expected ratio = 1e-07obtained abs = 0.000143245; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0445554; expected ratio = 0.0001obtained abs = 13.3138; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00229719; expected ratio = 1e-07obtained abs = 2.6539e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0073173; expected ratio = 0.0001obtained abs = 2.17435; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533819 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527310e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000681591; expected ratio = 1e-07obtained abs = 7.87447e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00143129; expected ratio = 0.0001obtained abs = 0.425036; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000248399; expected ratio = 1e-07obtained abs = 2.86978e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000665808; expected ratio = 0.0001obtained abs = 0.197716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000125265; expected ratio = 1e-07obtained abs = 1.44721e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000485376; expected ratio = 0.0001obtained abs = 0.144151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000584841 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.36594e-05; expected ratio = 1e-07obtained abs = 9.66532e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000413095; expected ratio = 0.0001obtained abs = 0.122702; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527310e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.33488e-05; expected ratio = 1e-07obtained abs = 7.31881e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000365796; expected ratio = 0.0001obtained abs = 0.108669; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.527310e+05 Mflops = 21.16 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.04081e-05; expected ratio = 1e-07obtained abs = 5.82376e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000327168; expected ratio = 0.0001obtained abs = 0.0972073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.11406e-05; expected ratio = 1e-07obtained abs = 4.75307e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000293106; expected ratio = 0.0001obtained abs = 0.0870988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000584126 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.4124e-05; expected ratio = 1e-07obtained abs = 3.94243e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000262253; expected ratio = 0.0001obtained abs = 0.0779403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.527310e+05 Mflops = 10.58 -Solve time = 0.02 -Solve flops = 2.419400e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.86282e-05; expected ratio = 1e-07obtained abs = 3.30749e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000234057; expected ratio = 0.0001obtained abs = 0.0695685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00059104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527310e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.42181e-05; expected ratio = 1e-07obtained abs = 2.79799e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000208262; expected ratio = 0.0001obtained abs = 0.0619076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533819 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.06141e-05; expected ratio = 1e-07obtained abs = 2.38161e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000184724; expected ratio = 0.0001obtained abs = 0.0549158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.7627e-05; expected ratio = 1e-07obtained abs = 2.0365e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000163339; expected ratio = 0.0001obtained abs = 0.0485624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.527310e+05 Mflops = 21.16 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.51241e-05; expected ratio = 1e-07obtained abs = 1.74733e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000144007; expected ratio = 0.0001obtained abs = 0.0428181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527310e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.30093e-05; expected ratio = 1e-07obtained abs = 1.50301e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126622; expected ratio = 0.0001obtained abs = 0.0376513; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.12113e-05; expected ratio = 1e-07obtained abs = 1.29527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000111063; expected ratio = 0.0001obtained abs = 0.0330267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.67513e-06; expected ratio = 1e-07obtained abs = 1.1178e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.72025e-05; expected ratio = 0.0001obtained abs = 0.0289064; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533819 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.35816e-06; expected ratio = 1e-07obtained abs = 9.65644e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.49059e-05; expected ratio = 0.0001obtained abs = 0.0252508; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.29 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.29 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000567913 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0334998; expected ratio = 1e-07obtained abs = 0.000396707; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.231353; expected ratio = 0.0001obtained abs = 61.2246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0029212; expected ratio = 1e-07obtained abs = 3.45878e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0137488; expected ratio = 0.0001obtained abs = 3.61449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00066185 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000631959; expected ratio = 1e-07obtained abs = 7.48302e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00187571; expected ratio = 0.0001obtained abs = 0.49248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000586987 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000207728; expected ratio = 1e-07obtained abs = 2.4597e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000696252; expected ratio = 0.0001obtained abs = 0.182718; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000111896; expected ratio = 1e-07obtained abs = 1.32495e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000534723; expected ratio = 0.0001obtained abs = 0.140285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.65402e-05; expected ratio = 1e-07obtained abs = 9.06303e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000468208; expected ratio = 0.0001obtained abs = 0.122803; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.83481e-05; expected ratio = 1e-07obtained abs = 6.9089e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000417561; expected ratio = 0.0001obtained abs = 0.109495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.75067e-05; expected ratio = 1e-07obtained abs = 5.62518e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0003742; expected ratio = 0.0001obtained abs = 0.0981049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.03399e-05; expected ratio = 1e-07obtained abs = 4.77657e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000336183; expected ratio = 0.0001obtained abs = 0.0881218; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.5174e-05; expected ratio = 1e-07obtained abs = 4.16487e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000302633; expected ratio = 0.0001obtained abs = 0.0793143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.11908e-05; expected ratio = 1e-07obtained abs = 3.69323e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000272917; expected ratio = 0.0001obtained abs = 0.0715158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000547171 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.7965e-05; expected ratio = 1e-07obtained abs = 3.31127e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000246513; expected ratio = 0.0001obtained abs = 0.0645881; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.52594e-05; expected ratio = 1e-07obtained abs = 2.9909e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000222978; expected ratio = 0.0001obtained abs = 0.0584147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.29319e-05; expected ratio = 1e-07obtained abs = 2.71531e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00020194; expected ratio = 0.0001obtained abs = 0.0528971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533819 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.08925e-05; expected ratio = 1e-07obtained abs = 2.47383e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000183083; expected ratio = 0.0001obtained abs = 0.0479529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000547171 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.90811e-05; expected ratio = 1e-07obtained abs = 2.25935e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000166143; expected ratio = 0.0001obtained abs = 0.0435121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.7456e-05; expected ratio = 1e-07obtained abs = 2.06692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000150895; expected ratio = 0.0001obtained abs = 0.0395153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.59873e-05; expected ratio = 1e-07obtained abs = 1.89302e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000137145; expected ratio = 0.0001obtained abs = 0.0359118; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.522830e+05 Mflops = 21.14 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.4653e-05; expected ratio = 1e-07obtained abs = 1.73502e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000124727; expected ratio = 0.0001obtained abs = 0.032658; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.34361e-05; expected ratio = 1e-07obtained abs = 1.59094e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113498; expected ratio = 0.0001obtained abs = 0.0297159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.23235e-05; expected ratio = 1e-07obtained abs = 1.45919e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103332; expected ratio = 0.0001obtained abs = 0.0270527; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533819 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.13043e-05; expected ratio = 1e-07obtained abs = 1.33851e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.41181e-05; expected ratio = 0.0001obtained abs = 0.0246393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.03695e-05; expected ratio = 1e-07obtained abs = 1.22783e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.57607e-05; expected ratio = 0.0001obtained abs = 0.0224503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.51166e-06; expected ratio = 1e-07obtained abs = 1.12625e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.81736e-05; expected ratio = 0.0001obtained abs = 0.0204633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.72397e-06; expected ratio = 1e-07obtained abs = 1.03298e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.12809e-05; expected ratio = 0.0001obtained abs = 0.0186583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533819 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.00057e-06; expected ratio = 1e-07obtained abs = 9.47327e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.5015e-05; expected ratio = 0.0001obtained abs = 0.0170175; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.3 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0271411; expected ratio = 1e-07obtained abs = 0.00032836; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.180165; expected ratio = 0.0001obtained abs = 54.4123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00357686; expected ratio = 1e-07obtained abs = 4.32518e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00988497; expected ratio = 0.0001obtained abs = 2.9938; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00103368; expected ratio = 1e-07obtained abs = 1.24998e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00255581; expected ratio = 0.0001obtained abs = 0.77477; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000537872 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000359018; expected ratio = 1e-07obtained abs = 4.34144e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00182669; expected ratio = 0.0001obtained abs = 0.553461; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.522830e+05 Mflops = 21.14 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000171154; expected ratio = 1e-07obtained abs = 2.0697e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000644008; expected ratio = 0.0001obtained abs = 0.19517; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000110637; expected ratio = 1e-07obtained abs = 1.3379e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000510427; expected ratio = 0.0001obtained abs = 0.154715; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.12162e-05; expected ratio = 1e-07obtained abs = 9.82123e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000445717; expected ratio = 0.0001obtained abs = 0.135123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.26398e-05; expected ratio = 1e-07obtained abs = 7.57486e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00039635; expected ratio = 0.0001obtained abs = 0.120176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.513150e+05 Mflops = 10.54 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.96214e-05; expected ratio = 1e-07obtained abs = 6.00059e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000353124; expected ratio = 0.0001obtained abs = 0.107086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.00292e-05; expected ratio = 1e-07obtained abs = 4.84064e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000313472; expected ratio = 0.0001obtained abs = 0.0950747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.27226e-05; expected ratio = 1e-07obtained abs = 3.95707e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000276717; expected ratio = 0.0001obtained abs = 0.0839378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.513150e+05 Mflops = 21.08 -Solve time = 0.02 -Solve flops = 2.415400e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.70143e-05; expected ratio = 1e-07obtained abs = 3.26678e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000242785; expected ratio = 0.0001obtained abs = 0.0736535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.513150e+05 Mflops = 7.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.24657e-05; expected ratio = 1e-07obtained abs = 2.71673e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000211751; expected ratio = 0.0001obtained abs = 0.0642455; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.51961e-05; expected ratio = 1e-07obtained abs = 3.04692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00144607; expected ratio = 0.0001obtained abs = 0.438674; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.71856e-05; expected ratio = 1e-07obtained abs = 2.07822e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000241991; expected ratio = 0.0001obtained abs = 0.0734194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.40171e-05; expected ratio = 1e-07obtained abs = 1.69507e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000149841; expected ratio = 0.0001obtained abs = 0.0454654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000660896 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.513150e+05 Mflops = 7.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17452e-05; expected ratio = 1e-07obtained abs = 1.42033e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000125493; expected ratio = 0.0001obtained abs = 0.03808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.91549e-06; expected ratio = 1e-07obtained abs = 1.19906e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107217; expected ratio = 0.0001obtained abs = 0.0325361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.39559e-06; expected ratio = 1e-07obtained abs = 1.01527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.14376e-05; expected ratio = 0.0001obtained abs = 0.0277491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528812 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.12103e-06; expected ratio = 1e-07obtained abs = 8.61135e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.77487e-05; expected ratio = 0.0001obtained abs = 0.0235958; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.31 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.31 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533819 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0243215; expected ratio = 1e-07obtained abs = 0.000300231; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155486; expected ratio = 0.0001obtained abs = 41.8488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00247449; expected ratio = 1e-07obtained abs = 3.05313e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00929503; expected ratio = 0.0001obtained abs = 2.50199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000662736; expected ratio = 1e-07obtained abs = 8.17728e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000843758; expected ratio = 0.0001obtained abs = 0.227088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00021357; expected ratio = 1e-07obtained abs = 2.63515e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000402553; expected ratio = 0.0001obtained abs = 0.108325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.33015e-05; expected ratio = 1e-07obtained abs = 1.02782e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000294254; expected ratio = 0.0001obtained abs = 0.07917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000675917 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.11501e-05; expected ratio = 1e-07obtained abs = 5.07732e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000246536; expected ratio = 0.0001obtained abs = 0.0663224; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.54117e-05; expected ratio = 1e-07obtained abs = 3.13543e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000212084; expected ratio = 0.0001obtained abs = 0.0570476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.520470e+05 Mflops = 21.12 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.83334e-05; expected ratio = 1e-07obtained abs = 2.26208e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000183395; expected ratio = 0.0001obtained abs = 0.0493258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.44078e-05; expected ratio = 1e-07obtained abs = 1.77771e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000158757; expected ratio = 0.0001obtained abs = 0.0426954; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.18131e-05; expected ratio = 1e-07obtained abs = 1.45757e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00013753; expected ratio = 0.0001obtained abs = 0.0369839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.89586e-06; expected ratio = 1e-07obtained abs = 1.221e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000119263; expected ratio = 0.0001obtained abs = 0.0320695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.520470e+05 Mflops = 10.56 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.38995e-06; expected ratio = 1e-07obtained abs = 1.03519e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103549; expected ratio = 0.0001obtained abs = 0.0278426; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.63163e-05; expected ratio = 1e-07obtained abs = 2.01319e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00170053; expected ratio = 0.0001obtained abs = 0.457366; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.97939e-06; expected ratio = 1e-07obtained abs = 1.10792e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000362788; expected ratio = 0.0001obtained abs = 0.0975617; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.520470e+05 Mflops = 21.12 -Solve time = 0.02 -Solve flops = 2.416400e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.78562e-06; expected ratio = 1e-07obtained abs = 8.37243e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131459; expected ratio = 0.0001obtained abs = 0.0353497; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.32 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.32 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0225766; expected ratio = 1e-07obtained abs = 0.000283924; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102476; expected ratio = 0.0001obtained abs = 30.0192; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.520470e+05 Mflops = 10.56 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00232634; expected ratio = 1e-07obtained abs = 2.92408e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00805259; expected ratio = 0.0001obtained abs = 2.35972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000662053; expected ratio = 1e-07obtained abs = 8.32176e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000796934; expected ratio = 0.0001obtained abs = 0.233488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000238381; expected ratio = 1e-07obtained abs = 2.99635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000373427; expected ratio = 0.0001obtained abs = 0.109389; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000564098 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000102924; expected ratio = 1e-07obtained abs = 1.29371e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000234388; expected ratio = 0.0001obtained abs = 0.0686511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.416400e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.14562e-05; expected ratio = 1e-07obtained abs = 6.46781e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000173496; expected ratio = 0.0001obtained abs = 0.0508109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.86197e-05; expected ratio = 1e-07obtained abs = 3.59737e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000137955; expected ratio = 0.0001obtained abs = 0.0403988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.7456e-05; expected ratio = 1e-07obtained abs = 2.19414e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113602; expected ratio = 0.0001obtained abs = 0.0332651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.16746e-05; expected ratio = 1e-07obtained abs = 1.46744e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.53916e-05; expected ratio = 0.0001obtained abs = 0.027931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.51928e-06; expected ratio = 1e-07obtained abs = 1.07084e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.11161e-05; expected ratio = 0.0001obtained abs = 0.02375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.520470e+05 Mflops = 10.56 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.67057e-06; expected ratio = 1e-07obtained abs = 8.38461e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.95995e-05; expected ratio = 0.0001obtained abs = 0.0203772; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.33 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.33 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0204905; expected ratio = 1e-07obtained abs = 0.00026227; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0807644; expected ratio = 0.0001obtained abs = 22.0655; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.533910e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00201032; expected ratio = 1e-07obtained abs = 2.57191e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00800268; expected ratio = 0.0001obtained abs = 2.18441; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000582802; expected ratio = 1e-07obtained abs = 7.45616e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000793062; expected ratio = 0.0001obtained abs = 0.216414; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000584126 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000213398; expected ratio = 1e-07obtained abs = 2.73012e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000367458; expected ratio = 0.0001obtained abs = 0.100256; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.29526e-05; expected ratio = 1e-07obtained abs = 1.18919e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000255563; expected ratio = 0.0001obtained abs = 0.0697174; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.533430e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.77263e-05; expected ratio = 1e-07obtained abs = 6.10585e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00021785; expected ratio = 0.0001obtained abs = 0.0594221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.533430e+05 Mflops = 10.60 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.87938e-05; expected ratio = 1e-07obtained abs = 3.68373e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000194452; expected ratio = 0.0001obtained abs = 0.0530345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.02885e-05; expected ratio = 1e-07obtained abs = 2.59561e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000174738; expected ratio = 0.0001obtained abs = 0.0476534; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.60608e-05; expected ratio = 1e-07obtained abs = 2.05473e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000156931; expected ratio = 0.0001obtained abs = 0.0427936; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.533430e+05 Mflops = 10.60 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.3583e-05; expected ratio = 1e-07obtained abs = 1.73773e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000140786; expected ratio = 0.0001obtained abs = 0.0383883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.533430e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.18623e-05; expected ratio = 1e-07obtained abs = 1.51759e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126241; expected ratio = 0.0001obtained abs = 0.0344199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000629902 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.05185e-05; expected ratio = 1e-07obtained abs = 1.34567e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113203; expected ratio = 0.0001obtained abs = 0.0308633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.39848e-06; expected ratio = 1e-07obtained abs = 1.20239e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00010155; expected ratio = 0.0001obtained abs = 0.0276849; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.533430e+05 Mflops = 21.20 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.43322e-06; expected ratio = 1e-07obtained abs = 1.0789e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.11465e-05; expected ratio = 0.0001obtained abs = 0.0248474; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.533430e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.58631e-06; expected ratio = 1e-07obtained abs = 9.7055e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.18583e-05; expected ratio = 0.0001obtained abs = 0.0223144; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.34 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.34 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.533430e+05 Mflops = 21.20 -Solve time = 0.02 -Solve flops = 2.420000e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0191814; expected ratio = 1e-07obtained abs = 0.000249571; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0567531; expected ratio = 0.0001obtained abs = 16.2612; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000582933 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.533430e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0018761; expected ratio = 1e-07obtained abs = 2.43985e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00727299; expected ratio = 0.0001obtained abs = 2.08346; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000535095; expected ratio = 1e-07obtained abs = 6.95891e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000779593; expected ratio = 0.0001obtained abs = 0.223305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000536919 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00019274; expected ratio = 1e-07obtained abs = 2.50656e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000317927; expected ratio = 0.0001obtained abs = 0.0910641; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.15982e-05; expected ratio = 1e-07obtained abs = 1.06118e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000154244; expected ratio = 0.0001obtained abs = 0.04418; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.533430e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.94324e-05; expected ratio = 1e-07obtained abs = 5.12813e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.01808e-05; expected ratio = 0.0001obtained abs = 0.0258306; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000546217 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.10132e-05; expected ratio = 1e-07obtained abs = 2.73273e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.12223e-05; expected ratio = 0.0001obtained abs = 0.0175361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533819 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.21877e-05; expected ratio = 1e-07obtained abs = 1.58499e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.6373e-05; expected ratio = 0.0001obtained abs = 0.0132829; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.7039e-06; expected ratio = 1e-07obtained abs = 1.00188e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.76885e-05; expected ratio = 0.0001obtained abs = 0.0107955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000537872 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.542170e+05 Mflops = 7.08 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.30749e-06; expected ratio = 1e-07obtained abs = 6.90231e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.19574e-05; expected ratio = 0.0001obtained abs = 0.00915395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.35 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.35 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000595093 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.543630e+05 Mflops = 21.26 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0179183; expected ratio = 1e-07obtained abs = 0.000236731; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0409299; expected ratio = 0.0001obtained abs = 11.3046; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.543630e+05 Mflops = 7.09 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00172917; expected ratio = 1e-07obtained abs = 2.28351e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00713116; expected ratio = 0.0001obtained abs = 1.96908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000480125; expected ratio = 1e-07obtained abs = 6.3405e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000819051; expected ratio = 0.0001obtained abs = 0.226137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000532866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000168925; expected ratio = 1e-07obtained abs = 2.2308e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000326565; expected ratio = 0.0001obtained abs = 0.0901629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.94173e-05; expected ratio = 1e-07obtained abs = 9.16713e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000147985; expected ratio = 0.0001obtained abs = 0.0408582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.543630e+05 Mflops = 10.63 -Solve time = 0.02 -Solve flops = 2.426200e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.22805e-05; expected ratio = 1e-07obtained abs = 4.26291e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.57058e-05; expected ratio = 0.0001obtained abs = 0.0209022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.62977e-05; expected ratio = 1e-07obtained abs = 2.15225e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.27468e-05; expected ratio = 0.0001obtained abs = 0.0118024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.73416e-06; expected ratio = 1e-07obtained abs = 1.15342e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.66644e-05; expected ratio = 0.0001obtained abs = 0.00736211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.95423e-06; expected ratio = 1e-07obtained abs = 6.54247e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.83699e-05; expected ratio = 0.0001obtained abs = 0.005072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.36 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.36 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0200908; expected ratio = 1e-07obtained abs = 0.000268238; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137357; expected ratio = 0.0001obtained abs = 39.4888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000594139 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179017; expected ratio = 1e-07obtained abs = 2.38966e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00661522; expected ratio = 0.0001obtained abs = 1.90464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527760e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00046059; expected ratio = 1e-07obtained abs = 6.14841e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000894238; expected ratio = 0.0001obtained abs = 0.257427; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000156819; expected ratio = 1e-07obtained abs = 2.09337e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000344851; expected ratio = 0.0001obtained abs = 0.099273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000609159 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.61865e-05; expected ratio = 1e-07obtained abs = 8.83519e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000178742; expected ratio = 0.0001obtained abs = 0.0514559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.42582e-05; expected ratio = 1e-07obtained abs = 4.5731e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000116129; expected ratio = 0.0001obtained abs = 0.0334318; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527760e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.10457e-05; expected ratio = 1e-07obtained abs = 2.80938e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.73751e-05; expected ratio = 0.0001obtained abs = 0.0251545; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.527760e+05 Mflops = 21.17 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.47734e-05; expected ratio = 1e-07obtained abs = 1.9721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.10816e-05; expected ratio = 0.0001obtained abs = 0.0204643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000597954 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.1351e-05; expected ratio = 1e-07obtained abs = 1.51524e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.00012e-05; expected ratio = 0.0001obtained abs = 0.0172746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.19438e-06; expected ratio = 1e-07obtained abs = 1.22735e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.1504e-05; expected ratio = 0.0001obtained abs = 0.0148285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.0005548 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527760e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.66112e-06; expected ratio = 1e-07obtained abs = 1.02268e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.45344e-05; expected ratio = 0.0001obtained abs = 0.0128221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527760e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.47864e-06; expected ratio = 1e-07obtained abs = 8.64832e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.86187e-05; expected ratio = 0.0001obtained abs = 0.0111191; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.37 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.37 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.490880e+05 Mflops = 6.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0164292; expected ratio = 1e-07obtained abs = 0.000221016; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0588682; expected ratio = 0.0001obtained abs = 16.4004; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.503760e+05 Mflops = 10.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00162055; expected ratio = 1e-07obtained abs = 2.17955e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00666053; expected ratio = 0.0001obtained abs = 1.85905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0004314; expected ratio = 1e-07obtained abs = 5.80215e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000962286; expected ratio = 0.0001obtained abs = 0.26863; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000152998; expected ratio = 1e-07obtained abs = 2.05776e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000365827; expected ratio = 0.0001obtained abs = 0.102129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.503760e+05 Mflops = 10.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.57678e-05; expected ratio = 1e-07obtained abs = 1.01904e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000183807; expected ratio = 0.0001obtained abs = 0.051315; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000618935 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.503760e+05 Mflops = 7.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.71112e-05; expected ratio = 1e-07obtained abs = 6.33621e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000117371; expected ratio = 0.0001obtained abs = 0.0327677; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.24984e-05; expected ratio = 1e-07obtained abs = 4.37086e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.58545e-05; expected ratio = 0.0001obtained abs = 0.0239691; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.35413e-05; expected ratio = 1e-07obtained abs = 3.16617e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.68731e-05; expected ratio = 0.0001obtained abs = 0.0186699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.503760e+05 Mflops = 21.02 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.75158e-05; expected ratio = 1e-07obtained abs = 2.35578e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.35123e-05; expected ratio = 0.0001obtained abs = 0.0149399; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000622034 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.503760e+05 Mflops = 7.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.3248e-05; expected ratio = 1e-07obtained abs = 1.78179e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.33332e-05; expected ratio = 0.0001obtained abs = 0.0120981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.013e-05; expected ratio = 1e-07obtained abs = 1.36243e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.52935e-05; expected ratio = 0.0001obtained abs = 0.00985354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.80675e-06; expected ratio = 1e-07obtained abs = 1.04997e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.88407e-05; expected ratio = 0.0001obtained abs = 0.00805203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.05311e-06; expected ratio = 1e-07obtained abs = 8.14111e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.3623e-05; expected ratio = 0.0001obtained abs = 0.00659532; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.38 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.38 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0117315; expected ratio = 1e-07obtained abs = 0.000158811; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0320019; expected ratio = 0.0001obtained abs = 9.12194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00157193; expected ratio = 1e-07obtained abs = 2.12757e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00601422; expected ratio = 0.0001obtained abs = 1.71843; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.490880e+05 Mflops = 6.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000406874; expected ratio = 1e-07obtained abs = 5.50697e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00261617; expected ratio = 0.0001obtained abs = 0.74793; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000142697; expected ratio = 1e-07obtained abs = 1.93138e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000440656; expected ratio = 0.0001obtained abs = 0.125998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.51361e-05; expected ratio = 1e-07obtained abs = 1.01695e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000236741; expected ratio = 0.0001obtained abs = 0.0676969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.08182e-05; expected ratio = 1e-07obtained abs = 6.87807e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000163156; expected ratio = 0.0001obtained abs = 0.0466575; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.490880e+05 Mflops = 10.47 -Solve time = 0.02 -Solve flops = 2.409800e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.78947e-05; expected ratio = 1e-07obtained abs = 5.1289e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000123903; expected ratio = 0.0001obtained abs = 0.0354339; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.490880e+05 Mflops = 20.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.94451e-05; expected ratio = 1e-07obtained abs = 3.98528e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.81358e-05; expected ratio = 0.0001obtained abs = 0.0280657; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.33798e-05; expected ratio = 1e-07obtained abs = 3.16436e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.92417e-05; expected ratio = 0.0001obtained abs = 0.0226628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000617027 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.88117e-05; expected ratio = 1e-07obtained abs = 2.54609e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.46208e-05; expected ratio = 0.0001obtained abs = 0.0184817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.490880e+05 Mflops = 6.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.52733e-05; expected ratio = 1e-07obtained abs = 2.06717e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.29998e-05; expected ratio = 0.0001obtained abs = 0.0151583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.0005548 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.490880e+05 Mflops = 10.47 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.24825e-05; expected ratio = 1e-07obtained abs = 1.68944e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.36323e-05; expected ratio = 0.0001obtained abs = 0.0124793; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.02538e-05; expected ratio = 1e-07obtained abs = 1.3878e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.60207e-05; expected ratio = 0.0001obtained abs = 0.0103024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000607967 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.45774e-06; expected ratio = 1e-07obtained abs = 1.14471e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.98053e-05; expected ratio = 0.0001obtained abs = 0.00852481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.490880e+05 Mflops = 10.47 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.00018e-06; expected ratio = 1e-07obtained abs = 9.4744e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.47128e-05; expected ratio = 0.0001obtained abs = 0.00706832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.39 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.39 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000617981 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0100688; expected ratio = 1e-07obtained abs = 0.000137024; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0296419; expected ratio = 0.0001obtained abs = 8.2997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.07 -Factor flops = 3.983120e+05 Mflops = 5.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00163073; expected ratio = 1e-07obtained abs = 2.21892e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0044206; expected ratio = 0.0001obtained abs = 1.23956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983120e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0005326; expected ratio = 1e-07obtained abs = 7.2471e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00151499; expected ratio = 0.0001obtained abs = 0.424722; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000607014 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000235839; expected ratio = 1e-07obtained abs = 3.20905e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000660858; expected ratio = 0.0001obtained abs = 0.185254; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000125337; expected ratio = 1e-07obtained abs = 1.70545e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000342346; expected ratio = 0.0001obtained abs = 0.0959627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000596046 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983120e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.38595e-05; expected ratio = 1e-07obtained abs = 1.005e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000192717; expected ratio = 0.0001obtained abs = 0.0540187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983120e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.68786e-05; expected ratio = 1e-07obtained abs = 6.37871e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000118293; expected ratio = 0.0001obtained abs = 0.0331571; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.19014e-05; expected ratio = 1e-07obtained abs = 4.34078e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.96412e-05; expected ratio = 0.0001obtained abs = 0.0223228; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.31986e-05; expected ratio = 1e-07obtained abs = 3.1566e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.84649e-05; expected ratio = 0.0001obtained abs = 0.0163872; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983120e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.538400e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.78296e-05; expected ratio = 1e-07obtained abs = 2.42604e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.58582e-05; expected ratio = 0.0001obtained abs = 0.0128536; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983120e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.42557e-05; expected ratio = 1e-07obtained abs = 1.93974e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.75333e-05; expected ratio = 0.0001obtained abs = 0.0105201; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.16879e-05; expected ratio = 1e-07obtained abs = 1.59035e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.14802e-05; expected ratio = 0.0001obtained abs = 0.00882352; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.72635e-06; expected ratio = 1e-07obtained abs = 1.32344e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.67579e-05; expected ratio = 0.0001obtained abs = 0.00749988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983120e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.16412e-06; expected ratio = 1e-07obtained abs = 1.11087e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.29072e-05; expected ratio = 0.0001obtained abs = 0.00642058; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.88753e-06; expected ratio = 1e-07obtained abs = 9.3717e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.96859e-05; expected ratio = 0.0001obtained abs = 0.00551768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.4 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000564098 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 4.002960e+05 Mflops = 8.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00990712; expected ratio = 1e-07obtained abs = 0.000135363; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234274; expected ratio = 0.0001obtained abs = 6.68184; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00172584; expected ratio = 1e-07obtained abs = 2.35788e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00459053; expected ratio = 0.0001obtained abs = 1.31212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000599016; expected ratio = 1e-07obtained abs = 8.18394e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00170066; expected ratio = 0.0001obtained abs = 0.485935; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983060e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000281069; expected ratio = 1e-07obtained abs = 3.84006e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000805492; expected ratio = 0.0001obtained abs = 0.230121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000155206; expected ratio = 1e-07obtained abs = 2.12048e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000442265; expected ratio = 0.0001obtained abs = 0.12634; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.22146e-05; expected ratio = 1e-07obtained abs = 1.25987e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000257674; expected ratio = 0.0001obtained abs = 0.0736056; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.67043e-05; expected ratio = 1e-07obtained abs = 7.74714e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000156986; expected ratio = 0.0001obtained abs = 0.0448427; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983060e+05 Mflops = 23.90 -Solve time = 0.02 -Solve flops = 2.540600e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.55571e-05; expected ratio = 1e-07obtained abs = 4.85793e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.9141e-05; expected ratio = 0.0001obtained abs = 0.028319; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.07 -Factor flops = 3.983060e+05 Mflops = 5.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.26034e-05; expected ratio = 1e-07obtained abs = 3.08815e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.45944e-05; expected ratio = 0.0001obtained abs = 0.0184509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.45357e-05; expected ratio = 1e-07obtained abs = 1.98592e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.33007e-05; expected ratio = 0.0001obtained abs = 0.0123685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.45479e-06; expected ratio = 1e-07obtained abs = 1.29175e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.98052e-05; expected ratio = 0.0001obtained abs = 0.00851361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.983060e+05 Mflops = 11.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.2278e-06; expected ratio = 1e-07obtained abs = 8.50863e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.10254e-05; expected ratio = 0.0001obtained abs = 0.00600574; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.41 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.41 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00847074; expected ratio = 1e-07obtained abs = 0.000116092; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0285377; expected ratio = 0.0001obtained abs = 7.94868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.540600e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00148005; expected ratio = 1e-07obtained abs = 2.02834e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00390644; expected ratio = 0.0001obtained abs = 1.08991; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.983060e+05 Mflops = 11.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000484912; expected ratio = 1e-07obtained abs = 6.64554e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118398; expected ratio = 0.0001obtained abs = 0.330212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000215217; expected ratio = 1e-07obtained abs = 2.94948e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000533777; expected ratio = 0.0001obtained abs = 0.148845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000115171; expected ratio = 1e-07obtained abs = 1.57838e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000305188; expected ratio = 0.0001obtained abs = 0.085093; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.82663e-05; expected ratio = 1e-07obtained abs = 9.35569e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000190589; expected ratio = 0.0001obtained abs = 0.0531361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983060e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.28787e-05; expected ratio = 1e-07obtained abs = 5.8764e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000125176; expected ratio = 0.0001obtained abs = 0.0348972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.80528e-05; expected ratio = 1e-07obtained abs = 3.84456e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.49712e-05; expected ratio = 0.0001obtained abs = 0.0236878; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.9024e-05; expected ratio = 1e-07obtained abs = 2.60719e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.9247e-05; expected ratio = 0.0001obtained abs = 0.0165162; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.33761e-05; expected ratio = 1e-07obtained abs = 1.83316e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.23791e-05; expected ratio = 0.0001obtained abs = 0.0118137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983060e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.76009e-06; expected ratio = 1e-07obtained abs = 1.3376e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.11069e-05; expected ratio = 0.0001obtained abs = 0.00867134; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000609875 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.3809e-06; expected ratio = 1e-07obtained abs = 1.01153e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.34314e-05; expected ratio = 0.0001obtained abs = 0.00653166; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.75987e-06; expected ratio = 1e-07obtained abs = 7.89376e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.80922e-05; expected ratio = 0.0001obtained abs = 0.00504329; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.42 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.42 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00775041; expected ratio = 1e-07obtained abs = 0.000106439; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142258; expected ratio = 0.0001obtained abs = 4.00581; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00131267; expected ratio = 1e-07obtained abs = 1.80269e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00364818; expected ratio = 0.0001obtained abs = 1.02911; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000398799; expected ratio = 1e-07obtained abs = 5.47675e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000954252; expected ratio = 0.0001obtained abs = 0.269114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.983060e+05 Mflops = 11.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000165901; expected ratio = 1e-07obtained abs = 2.27834e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000392447; expected ratio = 0.0001obtained abs = 0.110664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.65881e-05; expected ratio = 1e-07obtained abs = 1.18912e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000213; expected ratio = 0.0001obtained abs = 0.0600584; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.19676e-05; expected ratio = 1e-07obtained abs = 7.13679e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000132695; expected ratio = 0.0001obtained abs = 0.0374132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.540600e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.38677e-05; expected ratio = 1e-07obtained abs = 4.65111e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.94367e-05; expected ratio = 0.0001obtained abs = 0.0252157; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.983060e+05 Mflops = 11.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.33512e-05; expected ratio = 1e-07obtained abs = 3.20686e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.30366e-05; expected ratio = 0.0001obtained abs = 0.017772; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.68262e-05; expected ratio = 1e-07obtained abs = 2.31077e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.58235e-05; expected ratio = 0.0001obtained abs = 0.0129189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.25777e-05; expected ratio = 1e-07obtained abs = 1.72732e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.42006e-05; expected ratio = 0.0001obtained abs = 0.00964194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000656128 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.69324e-06; expected ratio = 1e-07obtained abs = 1.33119e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.61651e-05; expected ratio = 0.0001obtained abs = 0.00737648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983060e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.65546e-06; expected ratio = 1e-07obtained abs = 1.05134e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.04861e-05; expected ratio = 0.0001obtained abs = 0.00577542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.16088e-06; expected ratio = 1e-07obtained abs = 8.46088e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.63741e-05; expected ratio = 0.0001obtained abs = 0.00461615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.43 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.43 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000559807 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0150835; expected ratio = 1e-07obtained abs = 0.000207017; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0300616; expected ratio = 0.0001obtained abs = 8.50792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00239385; expected ratio = 1e-07obtained abs = 3.28496e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00626358; expected ratio = 0.0001obtained abs = 1.78091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000649406; expected ratio = 1e-07obtained abs = 8.91148e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00243864; expected ratio = 0.0001obtained abs = 0.693409; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.970460e+05 Mflops = 7.94 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000255545; expected ratio = 1e-07obtained abs = 3.50674e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000520302; expected ratio = 0.0001obtained abs = 0.147945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000152673; expected ratio = 1e-07obtained abs = 2.09509e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000309585; expected ratio = 0.0001obtained abs = 0.0880264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00011001; expected ratio = 1e-07obtained abs = 1.50965e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000220341; expected ratio = 0.0001obtained abs = 0.0626492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000609875 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.993060e+05 Mflops = 23.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.39811e-05; expected ratio = 1e-07obtained abs = 1.15246e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000167321; expected ratio = 0.0001obtained abs = 0.0475733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.993060e+05 Mflops = 7.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.55734e-05; expected ratio = 1e-07obtained abs = 8.99863e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000130667; expected ratio = 0.0001obtained abs = 0.0371511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00056386 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.18422e-05; expected ratio = 1e-07obtained abs = 7.11432e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103706; expected ratio = 0.0001obtained abs = 0.0294854; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.134e-05; expected ratio = 1e-07obtained abs = 5.67311e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.32871e-05; expected ratio = 0.0001obtained abs = 0.0236797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.993060e+05 Mflops = 23.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.31865e-05; expected ratio = 1e-07obtained abs = 4.55422e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.7537e-05; expected ratio = 0.0001obtained abs = 0.0192016; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.993060e+05 Mflops = 7.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.67889e-05; expected ratio = 1e-07obtained abs = 3.67627e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.52125e-05; expected ratio = 0.0001obtained abs = 0.0156975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.17262e-05; expected ratio = 1e-07obtained abs = 2.98152e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.54473e-05; expected ratio = 0.0001obtained abs = 0.0129211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00062108 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.76912e-05; expected ratio = 1e-07obtained abs = 2.42779e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.76235e-05; expected ratio = 0.0001obtained abs = 0.0106967; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.993060e+05 Mflops = 23.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.4455e-05; expected ratio = 1e-07obtained abs = 1.98369e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.12937e-05; expected ratio = 0.0001obtained abs = 0.00889709; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000741959 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.993060e+05 Mflops = 7.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.18454e-05; expected ratio = 1e-07obtained abs = 1.62557e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.61295e-05; expected ratio = 0.0001obtained abs = 0.00742884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.73118e-06; expected ratio = 1e-07obtained abs = 1.33543e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.18862e-05; expected ratio = 0.0001obtained abs = 0.00622243; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.01121e-06; expected ratio = 1e-07obtained abs = 1.0994e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.8379e-05; expected ratio = 0.0001obtained abs = 0.00522531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.993060e+05 Mflops = 11.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.60708e-06; expected ratio = 1e-07obtained abs = 9.06705e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.54662e-05; expected ratio = 0.0001obtained abs = 0.00439715; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.44 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.44 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0126896; expected ratio = 1e-07obtained abs = 0.000173891; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0329314; expected ratio = 0.0001obtained abs = 9.1315; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.993060e+05 Mflops = 7.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00195067; expected ratio = 1e-07obtained abs = 2.67322e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00402823; expected ratio = 0.0001obtained abs = 1.11905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000566006 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.998460e+05 Mflops = 23.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000538477; expected ratio = 1e-07obtained abs = 7.37937e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00105078; expected ratio = 0.0001obtained abs = 0.291835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000210392; expected ratio = 1e-07obtained abs = 2.88326e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000454859; expected ratio = 0.0001obtained abs = 0.126315; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000120463; expected ratio = 1e-07obtained abs = 1.65086e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000271584; expected ratio = 0.0001obtained abs = 0.075413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.50411e-05; expected ratio = 1e-07obtained abs = 1.16544e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000188577; expected ratio = 0.0001obtained abs = 0.0523609; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.998460e+05 Mflops = 23.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.42788e-05; expected ratio = 1e-07obtained abs = 8.80908e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000139144; expected ratio = 0.0001obtained abs = 0.0386337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.97544e-05; expected ratio = 1e-07obtained abs = 6.81861e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000105465; expected ratio = 0.0001obtained abs = 0.0292816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.89745e-05; expected ratio = 1e-07obtained abs = 5.34129e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.1253e-05; expected ratio = 0.0001obtained abs = 0.022559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.07 -Factor flops = 3.998460e+05 Mflops = 6.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.07796e-05; expected ratio = 1e-07obtained abs = 4.21822e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.34143e-05; expected ratio = 0.0001obtained abs = 0.017606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.44635e-05; expected ratio = 1e-07obtained abs = 3.35264e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.00597e-05; expected ratio = 0.0001obtained abs = 0.0138982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.95461e-05; expected ratio = 1e-07obtained abs = 2.67872e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.99254e-05; expected ratio = 0.0001obtained abs = 0.0110845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.56856e-05; expected ratio = 1e-07obtained abs = 2.14965e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.21359e-05; expected ratio = 0.0001obtained abs = 0.00892181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.26332e-05; expected ratio = 1e-07obtained abs = 1.73135e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.60756e-05; expected ratio = 0.0001obtained abs = 0.00723928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.02054e-05; expected ratio = 1e-07obtained abs = 1.39862e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.13074e-05; expected ratio = 0.0001obtained abs = 0.00591549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000567198 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.26441e-06; expected ratio = 1e-07obtained abs = 1.13261e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.75174e-05; expected ratio = 0.0001obtained abs = 0.00486328; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.70613e-06; expected ratio = 1e-07obtained abs = 9.19056e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.44776e-05; expected ratio = 0.0001obtained abs = 0.00401935; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.45 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.45 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0082025; expected ratio = 1e-07obtained abs = 0.000112191; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0159629; expected ratio = 0.0001obtained abs = 4.46889; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.998460e+05 Mflops = 23.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00151493; expected ratio = 1e-07obtained abs = 2.07231e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00402233; expected ratio = 0.0001obtained abs = 1.12768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00046675; expected ratio = 1e-07obtained abs = 6.38481e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0010629; expected ratio = 0.0001obtained abs = 0.297926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191016; expected ratio = 1e-07obtained abs = 2.61298e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000388673; expected ratio = 0.0001obtained abs = 0.108943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000103246; expected ratio = 1e-07obtained abs = 1.41234e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000191452; expected ratio = 0.0001obtained abs = 0.0536628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000852108 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.998460e+05 Mflops = 12.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.91344e-05; expected ratio = 1e-07obtained abs = 9.45723e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000118122; expected ratio = 0.0001obtained abs = 0.0331089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.07 -Factor flops = 3.998460e+05 Mflops = 6.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.12856e-05; expected ratio = 1e-07obtained abs = 7.01564e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.39616e-05; expected ratio = 0.0001obtained abs = 0.0235337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.95846e-05; expected ratio = 1e-07obtained abs = 5.41501e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.35015e-05; expected ratio = 0.0001obtained abs = 0.0177989; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.10445e-05; expected ratio = 1e-07obtained abs = 4.24677e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.92298e-05; expected ratio = 0.0001obtained abs = 0.0137986; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.998460e+05 Mflops = 12.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.45333e-05; expected ratio = 1e-07obtained abs = 3.35607e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.86028e-05; expected ratio = 0.0001obtained abs = 0.0108199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.94742e-05; expected ratio = 1e-07obtained abs = 2.66401e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.04749e-05; expected ratio = 0.0001obtained abs = 0.00854174; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.5505e-05; expected ratio = 1e-07obtained abs = 2.12104e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.41767e-05; expected ratio = 0.0001obtained abs = 0.00677642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.23722e-05; expected ratio = 1e-07obtained abs = 1.69248e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.92567e-05; expected ratio = 0.0001obtained abs = 0.00539739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.998460e+05 Mflops = 12.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.88906e-06; expected ratio = 1e-07obtained abs = 1.3528e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.53902e-05; expected ratio = 0.0001obtained abs = 0.00431367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000728846 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.998460e+05 Mflops = 12.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.91475e-06; expected ratio = 1e-07obtained abs = 1.08272e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.23373e-05; expected ratio = 0.0001obtained abs = 0.00345797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.34118e-06; expected ratio = 1e-07obtained abs = 8.67456e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.91727e-06; expected ratio = 0.0001obtained abs = 0.00277967; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.46 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.46 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.993060e+05 Mflops = 23.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0085174; expected ratio = 1e-07obtained abs = 0.000116154; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.015029; expected ratio = 0.0001obtained abs = 4.17751; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00137582; expected ratio = 1e-07obtained abs = 1.87649e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00391662; expected ratio = 0.0001obtained abs = 1.09113; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000419836; expected ratio = 1e-07obtained abs = 5.72616e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000947507; expected ratio = 0.0001obtained abs = 0.263926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.955780e+05 Mflops = 7.91 -Solve time = 0.02 -Solve flops = 2.530600e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000167841; expected ratio = 1e-07obtained abs = 2.28919e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00035265; expected ratio = 0.0001obtained abs = 0.0982279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.955780e+05 Mflops = 23.73 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.76553e-05; expected ratio = 1e-07obtained abs = 1.19554e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000169525; expected ratio = 0.0001obtained abs = 0.047219; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000607014 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.68515e-05; expected ratio = 1e-07obtained abs = 7.75408e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000101125; expected ratio = 0.0001obtained abs = 0.0281666; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.12281e-05; expected ratio = 1e-07obtained abs = 5.62319e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.97222e-05; expected ratio = 0.0001obtained abs = 0.0194195; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.955780e+05 Mflops = 7.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.13123e-05; expected ratio = 1e-07obtained abs = 4.27077e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.13692e-05; expected ratio = 0.0001obtained abs = 0.0143075; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.42415e-05; expected ratio = 1e-07obtained abs = 3.30636e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.88841e-05; expected ratio = 0.0001obtained abs = 0.0108301; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.89368e-05; expected ratio = 1e-07obtained abs = 2.58285e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.98046e-05; expected ratio = 0.0001obtained abs = 0.00830116; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.48665e-05; expected ratio = 1e-07obtained abs = 2.02769e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.30167e-05; expected ratio = 0.0001obtained abs = 0.00641056; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.955780e+05 Mflops = 7.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17079e-05; expected ratio = 1e-07obtained abs = 1.59688e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.78728e-05; expected ratio = 0.0001obtained abs = 0.00497787; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.24077e-06; expected ratio = 1e-07obtained abs = 1.26038e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.39411e-05; expected ratio = 0.0001obtained abs = 0.00388282; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.30557e-06; expected ratio = 1e-07obtained abs = 9.96434e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.09162e-05; expected ratio = 0.0001obtained abs = 0.00304034; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.47 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.47 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000562191 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0112778; expected ratio = 1e-07obtained abs = 0.000153125; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0232987; expected ratio = 0.0001obtained abs = 6.54062; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.001753; expected ratio = 1e-07obtained abs = 2.38042e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00521818; expected ratio = 0.0001obtained abs = 1.47092; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.944580e+05 Mflops = 23.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000532988; expected ratio = 1e-07obtained abs = 7.23745e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000971287; expected ratio = 0.0001obtained abs = 0.2738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.944580e+05 Mflops = 7.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000204512; expected ratio = 1e-07obtained abs = 2.77707e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000381901; expected ratio = 0.0001obtained abs = 0.107657; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556231 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.98335e-05; expected ratio = 1e-07obtained abs = 1.35565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000181436; expected ratio = 0.0001obtained abs = 0.051145; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000573158 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.0383e-05; expected ratio = 1e-07obtained abs = 8.19949e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103671; expected ratio = 0.0001obtained abs = 0.0292231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.944580e+05 Mflops = 23.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.15837e-05; expected ratio = 1e-07obtained abs = 5.64672e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.79504e-05; expected ratio = 0.0001obtained abs = 0.0191537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.944580e+05 Mflops = 7.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.04815e-05; expected ratio = 1e-07obtained abs = 4.13914e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.79465e-05; expected ratio = 0.0001obtained abs = 0.0135148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.29974e-05; expected ratio = 1e-07obtained abs = 3.12287e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.50194e-05; expected ratio = 0.0001obtained abs = 0.00987086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.76033e-05; expected ratio = 1e-07obtained abs = 2.39039e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.60223e-05; expected ratio = 0.0001obtained abs = 0.00733479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00402188 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.944580e+05 Mflops = 23.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.35851e-05; expected ratio = 1e-07obtained abs = 1.84476e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.95428e-05; expected ratio = 0.0001obtained abs = 0.0055084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.05393e-05; expected ratio = 1e-07obtained abs = 1.43115e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.47974e-05; expected ratio = 0.0001obtained abs = 0.00417082; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.20664e-06; expected ratio = 1e-07obtained abs = 1.1144e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.12872e-05; expected ratio = 0.0001obtained abs = 0.00318143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.944580e+05 Mflops = 7.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.4084e-06; expected ratio = 1e-07obtained abs = 8.70215e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.67208e-06; expected ratio = 0.0001obtained abs = 0.00244431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.48 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.48 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000611067 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.01507; expected ratio = 1e-07obtained abs = 0.00020335; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0364592; expected ratio = 0.0001obtained abs = 10.2346; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.575170e+05 Mflops = 7.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00253804; expected ratio = 1e-07obtained abs = 3.42523e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00590868; expected ratio = 0.0001obtained abs = 1.66633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000843741; expected ratio = 1e-07obtained abs = 1.13866e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00150605; expected ratio = 0.0001obtained abs = 0.424615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000344726; expected ratio = 1e-07obtained abs = 4.65221e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000776286; expected ratio = 0.0001obtained abs = 0.21883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00016796; expected ratio = 1e-07obtained abs = 2.26668e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000431693; expected ratio = 0.0001obtained abs = 0.121676; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.575170e+05 Mflops = 7.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.16105e-05; expected ratio = 1e-07obtained abs = 1.23632e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000251897; expected ratio = 0.0001obtained abs = 0.070993; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.37474e-05; expected ratio = 1e-07obtained abs = 7.25345e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0001547; expected ratio = 0.0001obtained abs = 0.0435966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.35261e-05; expected ratio = 1e-07obtained abs = 4.52451e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.98761e-05; expected ratio = 0.0001obtained abs = 0.0281452; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.21595e-05; expected ratio = 1e-07obtained abs = 2.99053e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.72738e-05; expected ratio = 0.0001obtained abs = 0.0189572; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.575170e+05 Mflops = 7.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.54073e-05; expected ratio = 1e-07obtained abs = 2.07929e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.67742e-05; expected ratio = 0.0001obtained abs = 0.0131802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.1133e-05; expected ratio = 1e-07obtained abs = 1.50246e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.32458e-05; expected ratio = 0.0001obtained abs = 0.009368; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000607014 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.25575e-06; expected ratio = 1e-07obtained abs = 1.11416e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.39941e-05; expected ratio = 0.0001obtained abs = 0.00676097; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.22207e-06; expected ratio = 1e-07obtained abs = 8.397e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.75176e-05; expected ratio = 0.0001obtained abs = 0.00493599; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.49 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.49 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000599146 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0186341; expected ratio = 1e-07obtained abs = 0.0002489; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121936; expected ratio = 0.0001obtained abs = 33.852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00262058; expected ratio = 1e-07obtained abs = 3.50082e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00813558; expected ratio = 0.0001obtained abs = 2.27144; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.477200e+05 Mflops = 6.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000888166; expected ratio = 1e-07obtained abs = 1.18648e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00140557; expected ratio = 0.0001obtained abs = 0.392509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000584126 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000368915; expected ratio = 1e-07obtained abs = 4.92822e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000623045; expected ratio = 0.0001obtained abs = 0.173992; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000182502; expected ratio = 1e-07obtained abs = 2.43798e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000337019; expected ratio = 0.0001obtained abs = 0.0941161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000100619; expected ratio = 1e-07obtained abs = 1.34414e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00020286; expected ratio = 0.0001obtained abs = 0.0566503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000621796 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.484340e+05 Mflops = 6.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.87875e-05; expected ratio = 1e-07obtained abs = 7.85322e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000128593; expected ratio = 0.0001obtained abs = 0.0359103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000605822 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.54856e-05; expected ratio = 1e-07obtained abs = 4.7404e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.42572e-05; expected ratio = 0.0001obtained abs = 0.0235293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000582933 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.18893e-05; expected ratio = 1e-07obtained abs = 2.92412e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.71313e-05; expected ratio = 0.0001obtained abs = 0.0159542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.37474e-05; expected ratio = 1e-07obtained abs = 1.83648e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.04143e-05; expected ratio = 0.0001obtained abs = 0.0112859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.484340e+05 Mflops = 6.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.79667e-06; expected ratio = 1e-07obtained abs = 1.17512e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.00303e-05; expected ratio = 0.0001obtained abs = 0.00838606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.75919e-06; expected ratio = 1e-07obtained abs = 7.69352e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.34422e-05; expected ratio = 0.0001obtained abs = 0.00654631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.5 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000634909 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.758050e+05 Mflops = 7.52 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0206871; expected ratio = 1e-07obtained abs = 0.000272833; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.033779; expected ratio = 0.0001obtained abs = 9.51677; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00240289; expected ratio = 1e-07obtained abs = 3.16993e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00730994; expected ratio = 0.0001obtained abs = 2.07073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000744675; expected ratio = 1e-07obtained abs = 9.82365e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00124277; expected ratio = 0.0001obtained abs = 0.352064; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.758050e+05 Mflops = 22.55 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000288496; expected ratio = 1e-07obtained abs = 3.80578e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000538074; expected ratio = 0.0001obtained abs = 0.152437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.758050e+05 Mflops = 7.52 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000141971; expected ratio = 1e-07obtained abs = 1.87284e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000303865; expected ratio = 0.0001obtained abs = 0.086086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000582933 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.27393e-05; expected ratio = 1e-07obtained abs = 1.09148e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000199089; expected ratio = 0.0001obtained abs = 0.0564026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.24722e-05; expected ratio = 1e-07obtained abs = 6.92199e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000142078; expected ratio = 0.0001obtained abs = 0.0402511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.47926e-05; expected ratio = 1e-07obtained abs = 4.58975e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107837; expected ratio = 0.0001obtained abs = 0.0305505; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.756490e+05 Mflops = 7.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.38288e-05; expected ratio = 1e-07obtained abs = 3.14344e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.59474e-05; expected ratio = 0.0001obtained abs = 0.0243491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.68373e-05; expected ratio = 1e-07obtained abs = 2.22114e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.1045e-05; expected ratio = 0.0001obtained abs = 0.0201272; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.23028e-05; expected ratio = 1e-07obtained abs = 1.62295e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.02079e-05; expected ratio = 0.0001obtained abs = 0.017057; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000635147 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.756490e+05 Mflops = 22.54 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.31325e-06; expected ratio = 1e-07obtained abs = 1.22858e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.18414e-05; expected ratio = 0.0001obtained abs = 0.0146868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.756490e+05 Mflops = 7.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.29762e-06; expected ratio = 1e-07obtained abs = 9.62685e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.50727e-05; expected ratio = 0.0001obtained abs = 0.0127692; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -line49 -Estimating delta time -0.51 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.51 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973700e+05 Mflops = 8.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0172779; expected ratio = 1e-07obtained abs = 0.000224894; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0288706; expected ratio = 0.0001obtained abs = 7.97484; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000575781 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00197615; expected ratio = 1e-07obtained abs = 2.57295e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00563449; expected ratio = 0.0001obtained abs = 1.56308; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000650167 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000639832; expected ratio = 1e-07obtained abs = 8.33038e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00106825; expected ratio = 0.0001obtained abs = 0.296285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000272467; expected ratio = 1e-07obtained abs = 3.54738e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000545709; expected ratio = 0.0001obtained abs = 0.151338; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000593185 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.02 -Solve flops = 2.243200e+04 Mflops = 1.35 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000146253; expected ratio = 1e-07obtained abs = 1.90412e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000323974; expected ratio = 0.0001obtained abs = 0.0898383; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.03424e-05; expected ratio = 1e-07obtained abs = 1.1762e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000204691; expected ratio = 0.0001obtained abs = 0.0567583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000615835 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.00653e-05; expected ratio = 1e-07obtained abs = 7.82009e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000135562; expected ratio = 0.0001obtained abs = 0.0375887; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000578165 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.973280e+05 Mflops = 17.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.16966e-05; expected ratio = 1e-07obtained abs = 5.42859e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.39579e-05; expected ratio = 0.0001obtained abs = 0.0260523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058794 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.98106e-05; expected ratio = 1e-07obtained abs = 3.88111e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.79119e-05; expected ratio = 0.0001obtained abs = 0.0188302; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.17801e-05; expected ratio = 1e-07obtained abs = 2.8356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.0866e-05; expected ratio = 0.0001obtained abs = 0.0141038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.61736e-05; expected ratio = 1e-07obtained abs = 2.10568e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.92016e-05; expected ratio = 0.0001obtained abs = 0.0108695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.21561e-05; expected ratio = 1e-07obtained abs = 1.58263e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.08972e-05; expected ratio = 0.0001obtained abs = 0.00856695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.973280e+05 Mflops = 5.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.21771e-06; expected ratio = 1e-07obtained abs = 1.20007e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.47904e-05; expected ratio = 0.0001obtained abs = 0.0068737; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.03474e-06; expected ratio = 1e-07obtained abs = 9.15865e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.0183e-05; expected ratio = 0.0001obtained abs = 0.0055962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.52 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.52 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058794 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0171908; expected ratio = 1e-07obtained abs = 0.00022064; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115257; expected ratio = 0.0001obtained abs = 3.20506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000633001 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00187745; expected ratio = 1e-07obtained abs = 2.41035e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0053712; expected ratio = 0.0001obtained abs = 1.49898; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000634028; expected ratio = 1e-07obtained abs = 8.13972e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00120126; expected ratio = 0.0001obtained abs = 0.335114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000283493; expected ratio = 1e-07obtained abs = 3.63947e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000608542; expected ratio = 0.0001obtained abs = 0.169729; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.973280e+05 Mflops = 5.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000156801; expected ratio = 1e-07obtained abs = 2.01299e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000366894; expected ratio = 0.0001obtained abs = 0.102316; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.85594e-05; expected ratio = 1e-07obtained abs = 1.26529e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000236278; expected ratio = 0.0001obtained abs = 0.0658844; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000578165 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.63915e-05; expected ratio = 1e-07obtained abs = 8.52318e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00015718; expected ratio = 0.0001obtained abs = 0.0438257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00059104 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.65827e-05; expected ratio = 1e-07obtained abs = 5.98017e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000106916; expected ratio = 0.0001obtained abs = 0.0298095; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.02 -Solve flops = 2.243200e+04 Mflops = 1.35 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.35969e-05; expected ratio = 1e-07obtained abs = 4.31308e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.41261e-05; expected ratio = 0.0001obtained abs = 0.0206667; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.47408e-05; expected ratio = 1e-07obtained abs = 3.17614e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.23598e-05; expected ratio = 0.0001obtained abs = 0.0145979; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.85263e-05; expected ratio = 1e-07obtained abs = 2.37835e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.76997e-05; expected ratio = 0.0001obtained abs = 0.0105105; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.40643e-05; expected ratio = 1e-07obtained abs = 1.80553e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.76805e-05; expected ratio = 0.0001obtained abs = 0.00771714; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00072217 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.07972e-05; expected ratio = 1e-07obtained abs = 1.38611e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.0722e-05; expected ratio = 0.0001obtained abs = 0.00577712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000597954 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.973280e+05 Mflops = 5.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.36428e-06; expected ratio = 1e-07obtained abs = 1.07378e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.5802e-05; expected ratio = 0.0001obtained abs = 0.00440544; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.52637e-06; expected ratio = 1e-07obtained abs = 8.3783e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.22559e-05; expected ratio = 0.0001obtained abs = 0.00341682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.53 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.53 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.968160e+05 Mflops = 8.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.017721; expected ratio = 1e-07obtained abs = 0.000224053; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170836; expected ratio = 0.0001obtained abs = 4.69224; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00194897; expected ratio = 1e-07obtained abs = 2.46483e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00508637; expected ratio = 0.0001obtained abs = 1.40161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000629934; expected ratio = 1e-07obtained abs = 7.96643e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114276; expected ratio = 0.0001obtained abs = 0.314811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000629187 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000238737; expected ratio = 1e-07obtained abs = 3.01915e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00045804; expected ratio = 0.0001obtained abs = 0.126165; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000107648; expected ratio = 1e-07obtained abs = 1.36134e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000243253; expected ratio = 0.0001obtained abs = 0.0669964; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.91365e-05; expected ratio = 1e-07obtained abs = 7.47852e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000152078; expected ratio = 0.0001obtained abs = 0.0418822; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.81599e-05; expected ratio = 1e-07obtained abs = 4.82576e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103201; expected ratio = 0.0001obtained abs = 0.0284203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000642061 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.71388e-05; expected ratio = 1e-07obtained abs = 3.432e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.32709e-05; expected ratio = 0.0001obtained abs = 0.0201772; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.0322e-05; expected ratio = 1e-07obtained abs = 2.56994e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.38141e-05; expected ratio = 0.0001obtained abs = 0.0148189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.56474e-05; expected ratio = 1e-07obtained abs = 1.97879e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.07646e-05; expected ratio = 0.0001obtained abs = 0.0112253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.22475e-05; expected ratio = 1e-07obtained abs = 1.54883e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.17825e-05; expected ratio = 0.0001obtained abs = 0.00875181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00059104 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.68849e-06; expected ratio = 1e-07obtained abs = 1.22521e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.54185e-05; expected ratio = 0.0001obtained abs = 0.00699934; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.72098e-06; expected ratio = 1e-07obtained abs = 9.76399e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.07604e-05; expected ratio = 0.0001obtained abs = 0.00571664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.54 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.54 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577211 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0186288; expected ratio = 1e-07obtained abs = 0.000231735; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00933174; expected ratio = 0.0001obtained abs = 2.56623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00197486; expected ratio = 1e-07obtained abs = 2.45739e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00506811; expected ratio = 0.0001obtained abs = 1.39828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000657132; expected ratio = 1e-07obtained abs = 8.17673e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00110409; expected ratio = 0.0001obtained abs = 0.304566; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000608921 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000248841; expected ratio = 1e-07obtained abs = 3.09632e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000390629; expected ratio = 0.0001obtained abs = 0.10775; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000104881; expected ratio = 1e-07obtained abs = 1.30502e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000179914; expected ratio = 0.0001obtained abs = 0.0496248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.96035e-05; expected ratio = 1e-07obtained abs = 6.1721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104565; expected ratio = 0.0001obtained abs = 0.0288403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000626802 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.66312e-05; expected ratio = 1e-07obtained abs = 3.31368e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.04973e-05; expected ratio = 0.0001obtained abs = 0.0194435; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.63e-05; expected ratio = 1e-07obtained abs = 2.02818e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.10864e-05; expected ratio = 0.0001obtained abs = 0.0140896; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.11651e-05; expected ratio = 1e-07obtained abs = 1.38925e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.86673e-05; expected ratio = 0.0001obtained abs = 0.0106643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000937939 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.02 -Solve flops = 2.230200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.26447e-06; expected ratio = 1e-07obtained abs = 1.02833e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.02998e-05; expected ratio = 0.0001obtained abs = 0.00835645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000627995 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.40314e-06; expected ratio = 1e-07obtained abs = 7.9673e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.44495e-05; expected ratio = 0.0001obtained abs = 0.00674294; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.55 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.55 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000599861 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.019535; expected ratio = 1e-07obtained abs = 0.000238822; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0133622; expected ratio = 0.0001obtained abs = 3.6461; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00185461; expected ratio = 1e-07obtained abs = 2.26803e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00563334; expected ratio = 0.0001obtained abs = 1.54189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000621524; expected ratio = 1e-07obtained abs = 7.60049e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00111914; expected ratio = 0.0001obtained abs = 0.30625; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00024144; expected ratio = 1e-07obtained abs = 2.9525e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00041727; expected ratio = 0.0001obtained abs = 0.114175; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00059104 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000104879; expected ratio = 1e-07obtained abs = 1.28252e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000203159; expected ratio = 0.0001obtained abs = 0.0555846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.0362e-05; expected ratio = 1e-07obtained abs = 6.15859e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000121629; expected ratio = 0.0001obtained abs = 0.0332757; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.64451e-05; expected ratio = 1e-07obtained abs = 3.23387e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.10341e-05; expected ratio = 0.0001obtained abs = 0.0221687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000575781 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.51023e-05; expected ratio = 1e-07obtained abs = 1.84681e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.66059e-05; expected ratio = 0.0001obtained abs = 0.0154853; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000578165 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.02 -Solve flops = 2.230200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.34932e-06; expected ratio = 1e-07obtained abs = 1.14329e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.08166e-05; expected ratio = 0.0001obtained abs = 0.0111657; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00064683 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.23585e-06; expected ratio = 1e-07obtained abs = 7.62557e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.03977e-05; expected ratio = 0.0001obtained abs = 0.00831541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.56 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.56 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000645161 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0205676; expected ratio = 1e-07obtained abs = 0.000246814; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00850706; expected ratio = 0.0001obtained abs = 2.31899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00181284; expected ratio = 1e-07obtained abs = 2.17611e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00586121; expected ratio = 0.0001obtained abs = 1.6025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000616098; expected ratio = 1e-07obtained abs = 7.3954e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114223; expected ratio = 0.0001obtained abs = 0.312222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000591993 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000245098; expected ratio = 1e-07obtained abs = 2.94204e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000442558; expected ratio = 0.0001obtained abs = 0.120957; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000110412; expected ratio = 1e-07obtained abs = 1.32533e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00021999; expected ratio = 0.0001obtained abs = 0.0601212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.56643e-05; expected ratio = 1e-07obtained abs = 6.68166e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131671; expected ratio = 0.0001obtained abs = 0.0359822; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.08605e-05; expected ratio = 1e-07obtained abs = 3.70433e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.67522e-05; expected ratio = 0.0001obtained abs = 0.0237059; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.84892e-05; expected ratio = 1e-07obtained abs = 2.21935e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.96111e-05; expected ratio = 0.0001obtained abs = 0.0162888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17762e-05; expected ratio = 1e-07obtained abs = 1.41356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.20196e-05; expected ratio = 0.0001obtained abs = 0.0114816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000591993 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.86084e-06; expected ratio = 1e-07obtained abs = 9.43573e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.03701e-05; expected ratio = 0.0001obtained abs = 0.00829832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.57 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.57 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000676155 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.956840e+05 Mflops = 5.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0216971; expected ratio = 1e-07obtained abs = 0.00025525; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01129; expected ratio = 0.0001obtained abs = 3.05909; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179618; expected ratio = 1e-07obtained abs = 2.11373e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00614217; expected ratio = 0.0001obtained abs = 1.66904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000622848; expected ratio = 1e-07obtained abs = 7.32944e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114498; expected ratio = 0.0001obtained abs = 0.311053; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000625849 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000254159; expected ratio = 1e-07obtained abs = 2.99082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000455136; expected ratio = 0.0001obtained abs = 0.123632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00011814; expected ratio = 1e-07obtained abs = 1.39021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000232356; expected ratio = 0.0001obtained abs = 0.0631103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00059104 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.16357e-05; expected ratio = 1e-07obtained abs = 7.25297e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000141746; expected ratio = 0.0001obtained abs = 0.0384971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.52883e-05; expected ratio = 1e-07obtained abs = 4.15254e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.44204e-05; expected ratio = 0.0001obtained abs = 0.0256425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000591993 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.16983e-05; expected ratio = 1e-07obtained abs = 2.55334e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.52594e-05; expected ratio = 0.0001obtained abs = 0.0177223; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.40674e-05; expected ratio = 1e-07obtained abs = 1.65538e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.60593e-05; expected ratio = 0.0001obtained abs = 0.0125079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.47702e-06; expected ratio = 1e-07obtained abs = 1.11521e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.31522e-05; expected ratio = 0.0001obtained abs = 0.00900267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.56546e-06; expected ratio = 1e-07obtained abs = 7.72588e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.44168e-05; expected ratio = 0.0001obtained abs = 0.00663044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.58 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.58 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000590086 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0228948; expected ratio = 1e-07obtained abs = 0.000263698; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00892099; expected ratio = 0.0001obtained abs = 2.41132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179031; expected ratio = 1e-07obtained abs = 2.06268e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00643953; expected ratio = 0.0001obtained abs = 1.74541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000634399; expected ratio = 1e-07obtained abs = 7.30896e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00115807; expected ratio = 0.0001obtained abs = 0.313809; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000595093 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000265041; expected ratio = 1e-07obtained abs = 3.05354e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00047347; expected ratio = 0.0001obtained abs = 0.128283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000633955 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.956840e+05 Mflops = 5.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000126376; expected ratio = 1e-07obtained abs = 1.45597e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000246681; expected ratio = 0.0001obtained abs = 0.0668296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000636816 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.76212e-05; expected ratio = 1e-07obtained abs = 7.79061e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000152072; expected ratio = 0.0001obtained abs = 0.0411956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.96138e-05; expected ratio = 1e-07obtained abs = 4.56388e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000101936; expected ratio = 0.0001obtained abs = 0.0276125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.48382e-05; expected ratio = 1e-07obtained abs = 2.8616e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.08432e-05; expected ratio = 0.0001obtained abs = 0.0191892; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.956840e+05 Mflops = 5.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.63633e-05; expected ratio = 1e-07obtained abs = 1.88521e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.02372e-05; expected ratio = 0.0001obtained abs = 0.0136073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000636101 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.956840e+05 Mflops = 17.74 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.11668e-05; expected ratio = 1e-07obtained abs = 1.28652e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.62557e-05; expected ratio = 0.0001obtained abs = 0.00982008; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.81454e-06; expected ratio = 1e-07obtained abs = 9.00308e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.66802e-05; expected ratio = 0.0001obtained abs = 0.0072264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.59 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.59 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0241659; expected ratio = 1e-07obtained abs = 0.000272137; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103399; expected ratio = 0.0001obtained abs = 2.78127; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179002; expected ratio = 1e-07obtained abs = 2.01637e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00678411; expected ratio = 0.0001obtained abs = 1.82971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000648682; expected ratio = 1e-07obtained abs = 7.30693e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00116932; expected ratio = 0.0001obtained abs = 0.31529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580788 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.02 -Solve flops = 2.240200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000277145; expected ratio = 1e-07obtained abs = 3.12182e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000488005; expected ratio = 0.0001obtained abs = 0.131567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0001351; expected ratio = 1e-07obtained abs = 1.52179e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00025761; expected ratio = 0.0001obtained abs = 0.0694451; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.37046e-05; expected ratio = 1e-07obtained abs = 8.30221e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00015994; expected ratio = 0.0001obtained abs = 0.0431124; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.38473e-05; expected ratio = 1e-07obtained abs = 4.93902e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107812; expected ratio = 0.0001obtained abs = 0.0290593; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.963800e+05 Mflops = 17.78 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.78186e-05; expected ratio = 1e-07obtained abs = 3.13353e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.53748e-05; expected ratio = 0.0001obtained abs = 0.0203155; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.963800e+05 Mflops = 5.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.84995e-05; expected ratio = 1e-07obtained abs = 2.08381e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.37726e-05; expected ratio = 0.0001obtained abs = 0.0144927; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000584841 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.27271e-05; expected ratio = 1e-07obtained abs = 1.4336e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.90014e-05; expected ratio = 0.0001obtained abs = 0.0105114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.97284e-06; expected ratio = 1e-07obtained abs = 1.01071e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.8781e-05; expected ratio = 0.0001obtained abs = 0.00775673; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000582933 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.44129e-06; expected ratio = 1e-07obtained abs = 7.25556e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.16512e-05; expected ratio = 0.0001obtained abs = 0.0058351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.6 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0255106; expected ratio = 1e-07obtained abs = 0.00028048; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00936151; expected ratio = 0.0001obtained abs = 2.51023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000592947 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.963800e+05 Mflops = 17.78 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179407; expected ratio = 1e-07obtained abs = 1.97306e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00714131; expected ratio = 0.0001obtained abs = 1.91986; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.02 -Solve flops = 2.240200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000665184; expected ratio = 1e-07obtained abs = 7.31534e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118051; expected ratio = 0.0001obtained abs = 0.317286; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000582933 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000290492; expected ratio = 1e-07obtained abs = 3.19465e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000502944; expected ratio = 0.0001obtained abs = 0.135159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000144652; expected ratio = 1e-07obtained abs = 1.59079e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000268864; expected ratio = 0.0001obtained abs = 0.0722457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.03863e-05; expected ratio = 1e-07obtained abs = 8.84036e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000168076; expected ratio = 0.0001obtained abs = 0.0451597; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.963800e+05 Mflops = 5.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.85278e-05; expected ratio = 1e-07obtained abs = 5.33677e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113974; expected ratio = 0.0001obtained abs = 0.0306213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.11416e-05; expected ratio = 1e-07obtained abs = 3.42475e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.02353e-05; expected ratio = 0.0001obtained abs = 0.0215558; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000632048 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.09056e-05; expected ratio = 1e-07obtained abs = 2.29906e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.76707e-05; expected ratio = 0.0001obtained abs = 0.0154931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.45062e-05; expected ratio = 1e-07obtained abs = 1.59529e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.21245e-05; expected ratio = 0.0001obtained abs = 0.0113164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.963800e+05 Mflops = 5.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.03131e-05; expected ratio = 1e-07obtained abs = 1.13417e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.12554e-05; expected ratio = 0.0001obtained abs = 0.00839637; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.963800e+05 Mflops = 17.78 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.4659e-06; expected ratio = 1e-07obtained abs = 8.2105e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.35786e-05; expected ratio = 0.0001obtained abs = 0.00633403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.61 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.61 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000583172 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.956840e+05 Mflops = 8.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0269318; expected ratio = 1e-07obtained abs = 0.000288667; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100665; expected ratio = 0.0001obtained abs = 2.68789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00180143; expected ratio = 1e-07obtained abs = 1.93133e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00753159; expected ratio = 0.0001obtained abs = 2.0161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000683372; expected ratio = 1e-07obtained abs = 7.32637e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00119148; expected ratio = 0.0001obtained abs = 0.318862; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000304808; expected ratio = 1e-07obtained abs = 3.2678e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000517185; expected ratio = 0.0001obtained abs = 0.13839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000154916; expected ratio = 1e-07obtained abs = 1.66083e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000279391; expected ratio = 0.0001obtained abs = 0.0747526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000578165 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.76166e-05; expected ratio = 1e-07obtained abs = 9.39322e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00017561; expected ratio = 0.0001obtained abs = 0.0469816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.36162e-05; expected ratio = 1e-07obtained abs = 5.74809e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000119708; expected ratio = 0.0001obtained abs = 0.0320238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000689983 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.4756e-05; expected ratio = 1e-07obtained abs = 3.72612e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.48328e-05; expected ratio = 0.0001obtained abs = 0.0226931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000589848 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.35158e-05; expected ratio = 1e-07obtained abs = 2.52109e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.1441e-05; expected ratio = 0.0001obtained abs = 0.0164352; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000596046 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.64291e-05; expected ratio = 1e-07obtained abs = 1.76134e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.52219e-05; expected ratio = 0.0001obtained abs = 0.0120963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17576e-05; expected ratio = 1e-07obtained abs = 1.26051e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.37761e-05; expected ratio = 0.0001obtained abs = 0.00903454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577211 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.56928e-06; expected ratio = 1e-07obtained abs = 9.18697e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.55994e-05; expected ratio = 0.0001obtained abs = 0.00684732; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.62 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.62 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0284349; expected ratio = 1e-07obtained abs = 0.000296658; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00975753; expected ratio = 0.0001obtained abs = 2.5966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00181212; expected ratio = 1e-07obtained abs = 1.89096e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00794147; expected ratio = 0.0001obtained abs = 2.11848; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000703178; expected ratio = 1e-07obtained abs = 7.3376e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00120305; expected ratio = 0.0001obtained abs = 0.320847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000648022 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000320173; expected ratio = 1e-07obtained abs = 3.34096e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000532512; expected ratio = 0.0001obtained abs = 0.142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000585079 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000166088; expected ratio = 1e-07obtained abs = 1.7331e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000290911; expected ratio = 0.0001obtained abs = 0.0775663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.56613e-05; expected ratio = 1e-07obtained abs = 9.98209e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000183932; expected ratio = 0.0001obtained abs = 0.0490381; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.9399e-05; expected ratio = 1e-07obtained abs = 6.19818e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00012608; expected ratio = 0.0001obtained abs = 0.033612; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.89326e-05; expected ratio = 1e-07obtained abs = 4.06255e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.9981e-05; expected ratio = 0.0001obtained abs = 0.0239872; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.65659e-05; expected ratio = 1e-07obtained abs = 2.7721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.57082e-05; expected ratio = 0.0001obtained abs = 0.0175159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.86902e-05; expected ratio = 1e-07obtained abs = 1.95029e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.87756e-05; expected ratio = 0.0001obtained abs = 0.0130018; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.3461e-05; expected ratio = 1e-07obtained abs = 1.40464e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.67167e-05; expected ratio = 0.0001obtained abs = 0.00978716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.02 -Solve flops = 2.230200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.8717e-06; expected ratio = 1e-07obtained abs = 1.03009e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.80042e-05; expected ratio = 0.0001obtained abs = 0.00746465; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.34256e-06; expected ratio = 1e-07obtained abs = 7.66184e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.16335e-05; expected ratio = 0.0001obtained abs = 0.00576647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.63 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.63 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000649929 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0300249; expected ratio = 1e-07obtained abs = 0.0003044; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010192; expected ratio = 0.0001obtained abs = 2.70181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.956660e+05 Mflops = 17.74 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00182673; expected ratio = 1e-07obtained abs = 1.85228e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00838346; expected ratio = 0.0001obtained abs = 2.22765; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000724745; expected ratio = 1e-07obtained abs = 7.34873e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0012161; expected ratio = 0.0001obtained abs = 0.323065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000633001 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00033668; expected ratio = 1e-07obtained abs = 3.41384e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000548978; expected ratio = 0.0001obtained abs = 0.145821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000593901 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.956660e+05 Mflops = 5.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000178258; expected ratio = 1e-07obtained abs = 1.80748e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000303281; expected ratio = 0.0001obtained abs = 0.0805496; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000593185 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.956660e+05 Mflops = 8.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000104626; expected ratio = 1e-07obtained abs = 1.06087e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000192885; expected ratio = 0.0001obtained abs = 0.0512248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000616074 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.59887e-05; expected ratio = 1e-07obtained abs = 6.69103e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000132946; expected ratio = 0.0001obtained abs = 0.0353044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000649929 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.37772e-05; expected ratio = 1e-07obtained abs = 4.43886e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.55402e-05; expected ratio = 0.0001obtained abs = 0.0253699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000627041 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.956660e+05 Mflops = 8.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.01459e-05; expected ratio = 1e-07obtained abs = 3.05669e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.03306e-05; expected ratio = 0.0001obtained abs = 0.018675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000588894 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.956660e+05 Mflops = 8.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.13605e-05; expected ratio = 1e-07obtained abs = 2.16589e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.26408e-05; expected ratio = 0.0001obtained abs = 0.0139774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.54759e-05; expected ratio = 1e-07obtained abs = 1.5692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.99299e-05; expected ratio = 0.0001obtained abs = 0.0106021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.14099e-05; expected ratio = 1e-07obtained abs = 1.15692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.06455e-05; expected ratio = 0.0001obtained abs = 0.00813681; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.52929e-06; expected ratio = 1e-07obtained abs = 8.64842e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.37754e-05; expected ratio = 0.0001obtained abs = 0.00631261; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.64 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.64 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0317099; expected ratio = 1e-07obtained abs = 0.000311863; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102283; expected ratio = 0.0001obtained abs = 2.70222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00062108 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.938460e+05 Mflops = 17.63 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00184546; expected ratio = 1e-07obtained abs = 1.81515e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00884789; expected ratio = 0.0001obtained abs = 2.3429; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.938460e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000747508; expected ratio = 1e-07obtained abs = 7.35225e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00122892; expected ratio = 0.0001obtained abs = 0.325339; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000353791; expected ratio = 1e-07obtained abs = 3.47977e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000565605; expected ratio = 0.0001obtained abs = 0.149716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579119 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000190984; expected ratio = 1e-07obtained abs = 1.87844e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000315902; expected ratio = 0.0001obtained abs = 0.083611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000114199; expected ratio = 1e-07obtained abs = 1.12322e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00020203; expected ratio = 0.0001obtained abs = 0.0534676; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000582933 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.938460e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.31878e-05; expected ratio = 1e-07obtained abs = 7.19848e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000139956; expected ratio = 0.0001obtained abs = 0.0370373; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000628948 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.91749e-05; expected ratio = 1e-07obtained abs = 4.83665e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000101233; expected ratio = 0.0001obtained abs = 0.0267885; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000578165 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.41936e-05; expected ratio = 1e-07obtained abs = 3.36315e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50993e-05; expected ratio = 0.0001obtained abs = 0.0198721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.4409e-05; expected ratio = 1e-07obtained abs = 2.40078e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.66715e-05; expected ratio = 0.0001obtained abs = 0.0149955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00077796 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.938460e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.77884e-05; expected ratio = 1e-07obtained abs = 1.7496e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.33262e-05; expected ratio = 0.0001obtained abs = 0.011464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000633955 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.938460e+05 Mflops = 17.63 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.31793e-05; expected ratio = 1e-07obtained abs = 1.29627e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.34818e-05; expected ratio = 0.0001obtained abs = 0.00885904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.89488e-06; expected ratio = 1e-07obtained abs = 9.73223e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.61169e-05; expected ratio = 0.0001obtained abs = 0.00691025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.65 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.65 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.944320e+05 Mflops = 17.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0368365; expected ratio = 1e-07obtained abs = 0.000349849; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106224; expected ratio = 0.0001obtained abs = 27.8466; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00171273; expected ratio = 1e-07obtained abs = 1.62632e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010422; expected ratio = 0.0001obtained abs = 2.73931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000712095; expected ratio = 1e-07obtained abs = 6.76157e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00111645; expected ratio = 0.0001obtained abs = 0.293425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.944320e+05 Mflops = 17.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000339661; expected ratio = 1e-07obtained abs = 3.22517e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000538605; expected ratio = 0.0001obtained abs = 0.141541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.944320e+05 Mflops = 5.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000184116; expected ratio = 1e-07obtained abs = 1.74822e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000301175; expected ratio = 0.0001obtained abs = 0.0791393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000110531; expected ratio = 1e-07obtained abs = 1.04952e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000190973; expected ratio = 0.0001obtained abs = 0.0501779; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.1107e-05; expected ratio = 1e-07obtained abs = 6.75177e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131111; expected ratio = 0.0001obtained abs = 0.0344471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.78845e-05; expected ratio = 1e-07obtained abs = 4.54674e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.41789e-05; expected ratio = 0.0001obtained abs = 0.0247428; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.944320e+05 Mflops = 5.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.3298e-05; expected ratio = 1e-07obtained abs = 3.16172e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.95219e-05; expected ratio = 0.0001obtained abs = 0.0182642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.944320e+05 Mflops = 8.83 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.37207e-05; expected ratio = 1e-07obtained abs = 2.25233e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.22773e-05; expected ratio = 0.0001obtained abs = 0.0137335; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.72223e-05; expected ratio = 1e-07obtained abs = 1.6353e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.98552e-05; expected ratio = 0.0001obtained abs = 0.01047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.26975e-05; expected ratio = 1e-07obtained abs = 1.20565e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.07182e-05; expected ratio = 0.0001obtained abs = 0.00806956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.944320e+05 Mflops = 17.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.47935e-06; expected ratio = 1e-07obtained abs = 9.00084e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.38898e-05; expected ratio = 0.0001obtained abs = 0.00627569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.66 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.66 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000659943 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.044812; expected ratio = 1e-07obtained abs = 0.00040843; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0335469; expected ratio = 0.0001obtained abs = 8.97093; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.945100e+05 Mflops = 8.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00282807; expected ratio = 1e-07obtained abs = 2.57653e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0114858; expected ratio = 0.0001obtained abs = 3.08428; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000461817 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.945100e+05 Mflops = 5.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00115868; expected ratio = 1e-07obtained abs = 1.05559e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00153266; expected ratio = 0.0001obtained abs = 0.411569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000529505; expected ratio = 1e-07obtained abs = 4.82397e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000771195; expected ratio = 0.0001obtained abs = 0.207066; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000278296; expected ratio = 1e-07obtained abs = 2.53539e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000452487; expected ratio = 0.0001obtained abs = 0.121477; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000172751; expected ratio = 1e-07obtained abs = 1.57384e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000302325; expected ratio = 0.0001obtained abs = 0.0811547; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.945100e+05 Mflops = 5.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000121276; expected ratio = 1e-07obtained abs = 1.10489e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000220206; expected ratio = 0.0001obtained abs = 0.0591057; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000652075 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.07218e-05; expected ratio = 1e-07obtained abs = 8.26527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000168273; expected ratio = 0.0001obtained abs = 0.0451628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.98614e-05; expected ratio = 1e-07obtained abs = 6.3648e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131893; expected ratio = 0.0001obtained abs = 0.0353964; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.45667e-05; expected ratio = 1e-07obtained abs = 4.97138e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0001048; expected ratio = 0.0001obtained abs = 0.0281242; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.945100e+05 Mflops = 8.84 -Solve time = 0.02 -Solve flops = 2.239600e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.29693e-05; expected ratio = 1e-07obtained abs = 3.91479e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.39155e-05; expected ratio = 0.0001obtained abs = 0.0225187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.945100e+05 Mflops = 5.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.40214e-05; expected ratio = 1e-07obtained abs = 3.09959e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.75005e-05; expected ratio = 0.0001obtained abs = 0.0181131; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.70459e-05; expected ratio = 1e-07obtained abs = 2.46407e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.44549e-05; expected ratio = 0.0001obtained abs = 0.0146121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000485897 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.15691e-05; expected ratio = 1e-07obtained abs = 1.9651e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.40192e-05; expected ratio = 0.0001obtained abs = 0.0118116; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.72463e-05; expected ratio = 1e-07obtained abs = 1.57126e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.56379e-05; expected ratio = 0.0001obtained abs = 0.00956253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000584126 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.945100e+05 Mflops = 8.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.38199e-05; expected ratio = 1e-07obtained abs = 1.2591e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.8889e-05; expected ratio = 0.0001obtained abs = 0.00775153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.1095e-05; expected ratio = 1e-07obtained abs = 1.01084e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.34445e-05; expected ratio = 0.0001obtained abs = 0.0062906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.92176e-06; expected ratio = 1e-07obtained abs = 8.12839e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.90462e-05; expected ratio = 0.0001obtained abs = 0.00511042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.67 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.67 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0460379; expected ratio = 1e-07obtained abs = 0.000401375; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0324239; expected ratio = 0.0001obtained abs = 8.47261; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00263581; expected ratio = 1e-07obtained abs = 2.29714e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119448; expected ratio = 0.0001obtained abs = 3.13065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0012379; expected ratio = 1e-07obtained abs = 1.07884e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00140836; expected ratio = 0.0001obtained abs = 0.36899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000667095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.037290e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000644126; expected ratio = 1e-07obtained abs = 5.61354e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000698068; expected ratio = 0.0001obtained abs = 0.18285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.037290e+05 Mflops = 18.22 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00036083; expected ratio = 1e-07obtained abs = 3.14461e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000405341; expected ratio = 0.0001obtained abs = 0.106157; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000215573; expected ratio = 1e-07obtained abs = 1.8787e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000264975; expected ratio = 0.0001obtained abs = 0.0693876; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00013652; expected ratio = 1e-07obtained abs = 1.18976e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000188641; expected ratio = 0.0001obtained abs = 0.0493949; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.033690e+05 Mflops = 18.20 -Solve time = 0.02 -Solve flops = 2.267600e+04 Mflops = 1.36 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.12091e-05; expected ratio = 1e-07obtained abs = 7.94878e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000141988; expected ratio = 0.0001obtained abs = 0.0371768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.387e-05; expected ratio = 1e-07obtained abs = 5.56621e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000110556; expected ratio = 0.0001obtained abs = 0.0289458; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.64685e-05; expected ratio = 1e-07obtained abs = 4.04969e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.77486e-05; expected ratio = 0.0001obtained abs = 0.0229738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.47954e-05; expected ratio = 1e-07obtained abs = 3.03239e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.03507e-05; expected ratio = 0.0001obtained abs = 0.0184184; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.65936e-05; expected ratio = 1e-07obtained abs = 2.31761e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.66788e-05; expected ratio = 0.0001obtained abs = 0.0148388; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.06141e-05; expected ratio = 1e-07obtained abs = 1.7965e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.57661e-05; expected ratio = 0.0001obtained abs = 0.0119817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000585079 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.033690e+05 Mflops = 18.20 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.61343e-05; expected ratio = 1e-07obtained abs = 1.40609e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.69932e-05; expected ratio = 0.0001obtained abs = 0.00968481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000485897 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.27132e-05; expected ratio = 1e-07obtained abs = 1.10794e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.9922e-05; expected ratio = 0.0001obtained abs = 0.00783352; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000646114 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.00657e-05; expected ratio = 1e-07obtained abs = 8.77213e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.42196e-05; expected ratio = 0.0001obtained abs = 0.00634061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.68 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.68 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0483284; expected ratio = 1e-07obtained abs = 0.000401934; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0192212; expected ratio = 0.0001obtained abs = 5.06054; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00252645; expected ratio = 1e-07obtained abs = 2.10001e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0125718; expected ratio = 0.0001obtained abs = 3.31905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.033690e+05 Mflops = 9.10 -Solve time = 0.02 -Solve flops = 2.267600e+04 Mflops = 1.36 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00125664; expected ratio = 1e-07obtained abs = 1.04452e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00121948; expected ratio = 0.0001obtained abs = 0.32187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000713012; expected ratio = 1e-07obtained abs = 5.92654e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000603613; expected ratio = 0.0001obtained abs = 0.159291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000429241; expected ratio = 1e-07obtained abs = 3.56782e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000353966; expected ratio = 0.0001obtained abs = 0.0933994; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000270079; expected ratio = 1e-07obtained abs = 2.24486e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000233391; expected ratio = 0.0001obtained abs = 0.0615787; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000176454; expected ratio = 1e-07obtained abs = 1.46666e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00016739; expected ratio = 0.0001obtained abs = 0.0441624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00011941; expected ratio = 1e-07obtained abs = 9.92514e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126998; expected ratio = 0.0001obtained abs = 0.0335045; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.35357e-05; expected ratio = 1e-07obtained abs = 6.94335e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.97877e-05; expected ratio = 0.0001obtained abs = 0.0263251; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.02293e-05; expected ratio = 1e-07obtained abs = 5.00615e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.99777e-05; expected ratio = 0.0001obtained abs = 0.0210985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.45614e-05; expected ratio = 1e-07obtained abs = 3.70387e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.47341e-05; expected ratio = 0.0001obtained abs = 0.017077; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.033690e+05 Mflops = 9.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.36643e-05; expected ratio = 1e-07obtained abs = 2.79812e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.25989e-05; expected ratio = 0.0001obtained abs = 0.0138755; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.033690e+05 Mflops = 9.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.58445e-05; expected ratio = 1e-07obtained abs = 2.14815e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.27646e-05; expected ratio = 0.0001obtained abs = 0.0112812; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.00813e-05; expected ratio = 1e-07obtained abs = 1.66912e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.47349e-05; expected ratio = 0.0001obtained abs = 0.0091629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.57419e-05; expected ratio = 1e-07obtained abs = 1.30843e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.81669e-05; expected ratio = 0.0001obtained abs = 0.00743027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.033690e+05 Mflops = 18.20 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.24204e-05; expected ratio = 1e-07obtained abs = 1.03236e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.28004e-05; expected ratio = 0.0001obtained abs = 0.00601459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000591993 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.033690e+05 Mflops = 9.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.84665e-06; expected ratio = 1e-07obtained abs = 8.18436e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.84256e-05; expected ratio = 0.0001obtained abs = 0.00486055; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.69 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.69 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000459194 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.830380e+05 Mflops = 16.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0514344; expected ratio = 1e-07obtained abs = 0.000406768; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0220648; expected ratio = 0.0001obtained abs = 5.7394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.830380e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00244717; expected ratio = 1e-07obtained abs = 1.93368e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136991; expected ratio = 0.0001obtained abs = 3.57362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00116039; expected ratio = 1e-07obtained abs = 9.16886e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00125243; expected ratio = 0.0001obtained abs = 0.326675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000662189; expected ratio = 1e-07obtained abs = 5.23226e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000647788; expected ratio = 0.0001obtained abs = 0.168946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000400418; expected ratio = 1e-07obtained abs = 3.16387e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00039255; expected ratio = 0.0001obtained abs = 0.102369; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.830380e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000250883; expected ratio = 1e-07obtained abs = 1.98232e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000257217; expected ratio = 0.0001obtained abs = 0.0670728; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.830380e+05 Mflops = 8.49 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000161042; expected ratio = 1e-07obtained abs = 1.27245e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000176545; expected ratio = 0.0001obtained abs = 0.0460344; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000105389; expected ratio = 1e-07obtained abs = 8.32716e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000124948; expected ratio = 0.0001obtained abs = 0.0325793; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.01986e-05; expected ratio = 1e-07obtained abs = 5.54663e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.04889e-05; expected ratio = 0.0001obtained abs = 0.0235939; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.830380e+05 Mflops = 16.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.75897e-05; expected ratio = 1e-07obtained abs = 3.76021e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.67815e-05; expected ratio = 0.0001obtained abs = 0.0174122; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.830380e+05 Mflops = 8.49 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.28541e-05; expected ratio = 1e-07obtained abs = 2.5959e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.00808e-05; expected ratio = 0.0001obtained abs = 0.0130577; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.31095e-05; expected ratio = 1e-07obtained abs = 1.82596e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.80687e-05; expected ratio = 0.0001obtained abs = 0.00992567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.65638e-05; expected ratio = 1e-07obtained abs = 1.30876e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.92643e-05; expected ratio = 0.0001obtained abs = 0.00763006; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.20906e-05; expected ratio = 1e-07obtained abs = 9.55314e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.27012e-05; expected ratio = 0.0001obtained abs = 0.00591886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.7 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000460148 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0556339; expected ratio = 1e-07obtained abs = 0.000416623; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0219292; expected ratio = 0.0001obtained abs = 5.73556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00298297; expected ratio = 1e-07obtained abs = 2.23116e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.014889; expected ratio = 0.0001obtained abs = 3.90781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.828100e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00139467; expected ratio = 1e-07obtained abs = 1.04314e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00161883; expected ratio = 0.0001obtained abs = 0.424828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000486135 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.828100e+05 Mflops = 8.48 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000808757; expected ratio = 1e-07obtained abs = 6.04909e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000867088; expected ratio = 0.0001obtained abs = 0.227517; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000503586; expected ratio = 1e-07obtained abs = 3.76657e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00053564; expected ratio = 0.0001obtained abs = 0.140531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000327727; expected ratio = 1e-07obtained abs = 2.45123e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000357899; expected ratio = 0.0001obtained abs = 0.0938904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.828100e+05 Mflops = 16.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000219338; expected ratio = 1e-07obtained abs = 1.64053e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000250644; expected ratio = 0.0001obtained abs = 0.0657489; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.828100e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00014973; expected ratio = 1e-07obtained abs = 1.1199e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000180838; expected ratio = 0.0001obtained abs = 0.0474348; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454187 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000103855; expected ratio = 1e-07obtained abs = 7.76779e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000133341; expected ratio = 0.0001obtained abs = 0.0349747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458956 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.30751e-05; expected ratio = 1e-07obtained abs = 5.46564e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100131; expected ratio = 0.0001obtained abs = 0.0262632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.21352e-05; expected ratio = 1e-07obtained abs = 3.89945e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.64558e-05; expected ratio = 0.0001obtained abs = 0.0200529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.828100e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.77153e-05; expected ratio = 1e-07obtained abs = 2.82092e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.92904e-05; expected ratio = 0.0001obtained abs = 0.0155504; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.828100e+05 Mflops = 8.48 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.76684e-05; expected ratio = 1e-07obtained abs = 2.06946e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.66364e-05; expected ratio = 0.0001obtained abs = 0.0122314; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.05835e-05; expected ratio = 1e-07obtained abs = 1.53954e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.7148e-05; expected ratio = 0.0001obtained abs = 0.00974276; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.55236e-05; expected ratio = 1e-07obtained abs = 1.16108e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.99108e-05; expected ratio = 0.0001obtained abs = 0.00784459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000500917 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.1861e-05; expected ratio = 1e-07obtained abs = 8.87145e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.43e-05; expected ratio = 0.0001obtained abs = 0.00637304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.71 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.71 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0597204; expected ratio = 1e-07obtained abs = 0.000421664; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0246721; expected ratio = 0.0001obtained abs = 6.37407; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.212200e+04 Mflops = 1.33 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00312654; expected ratio = 1e-07obtained abs = 2.20394e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161885; expected ratio = 0.0001obtained abs = 4.19583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.839200e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00133592; expected ratio = 1e-07obtained abs = 9.41657e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00160568; expected ratio = 0.0001obtained abs = 0.416136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000769987; expected ratio = 1e-07obtained abs = 5.42746e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000865835; expected ratio = 0.0001obtained abs = 0.224367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000454903 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000486027; expected ratio = 1e-07obtained abs = 3.42589e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000555902; expected ratio = 0.0001obtained abs = 0.144037; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000326457; expected ratio = 1e-07obtained abs = 2.30111e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000386946; expected ratio = 0.0001obtained abs = 0.10025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.839200e+05 Mflops = 8.52 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000228533; expected ratio = 1e-07obtained abs = 1.61087e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000283837; expected ratio = 0.0001obtained abs = 0.073531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.839200e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000164708; expected ratio = 1e-07obtained abs = 1.16098e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000215596; expected ratio = 0.0001obtained abs = 0.0558489; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000121397; expected ratio = 1e-07obtained abs = 8.5569e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000167831; expected ratio = 0.0001obtained abs = 0.0434733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.1153e-05; expected ratio = 1e-07obtained abs = 6.42511e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000133071; expected ratio = 0.0001obtained abs = 0.0344678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.00045681 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.95585e-05; expected ratio = 1e-07obtained abs = 4.90298e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107029; expected ratio = 0.0001obtained abs = 0.0277215; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.839200e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.38435e-05; expected ratio = 1e-07obtained abs = 3.79527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.7058e-05; expected ratio = 0.0001obtained abs = 0.0225481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.22076e-05; expected ratio = 1e-07obtained abs = 2.97509e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.14381e-05; expected ratio = 0.0001obtained abs = 0.0185021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.34523e-05; expected ratio = 1e-07obtained abs = 2.35796e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.90165e-05; expected ratio = 0.0001obtained abs = 0.0152847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.00048089 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.67653e-05; expected ratio = 1e-07obtained abs = 1.88661e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.90014e-05; expected ratio = 0.0001obtained abs = 0.0126906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.839200e+05 Mflops = 8.52 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.15874e-05; expected ratio = 1e-07obtained abs = 1.52163e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.08367e-05; expected ratio = 0.0001obtained abs = 0.0105759; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.839200e+05 Mflops = 8.52 -Solve time = 0.02 -Solve flops = 2.215200e+04 Mflops = 1.33 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.75284e-05; expected ratio = 1e-07obtained abs = 1.23552e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.4123e-05; expected ratio = 0.0001obtained abs = 0.00883712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000453949 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.4312e-05; expected ratio = 1e-07obtained abs = 1.00881e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.85664e-05; expected ratio = 0.0001obtained abs = 0.00739801; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17394e-05; expected ratio = 1e-07obtained abs = 8.27477e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.39455e-05; expected ratio = 0.0001obtained abs = 0.00620126; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.72 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 145 - - Mesh vertices: 124 - Mesh triangles: 145 - Mesh edges: 235 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.72 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.065809; expected ratio = 1e-07obtained abs = 0.000436067; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0803949; expected ratio = 0.0001obtained abs = 20.6847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00719994; expected ratio = 1e-07obtained abs = 4.75929e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0303109; expected ratio = 0.0001obtained abs = 7.82149; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00481365; expected ratio = 1e-07obtained abs = 3.18295e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0188317; expected ratio = 0.0001obtained abs = 4.86362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000473022 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.900930e+05 Mflops = 8.70 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00318786; expected ratio = 1e-07obtained abs = 2.10855e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010944; expected ratio = 0.0001obtained abs = 2.82879; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00196394; expected ratio = 1e-07obtained abs = 1.29921e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00614343; expected ratio = 0.0001obtained abs = 1.58902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000468969 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0011847; expected ratio = 1e-07obtained abs = 7.83774e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00352377; expected ratio = 0.0001obtained abs = 0.911876; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000721351; expected ratio = 1e-07obtained abs = 4.77247e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00210162; expected ratio = 0.0001obtained abs = 0.544022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.900930e+05 Mflops = 5.80 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000449802; expected ratio = 1e-07obtained abs = 2.97594e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00131598; expected ratio = 0.0001obtained abs = 0.34072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.900930e+05 Mflops = 8.70 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000289216; expected ratio = 1e-07obtained abs = 1.91349e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00087323; expected ratio = 0.0001obtained abs = 0.226115; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000192668; expected ratio = 1e-07obtained abs = 1.27472e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000615041; expected ratio = 0.0001obtained abs = 0.159271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000470161 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133532; expected ratio = 1e-07obtained abs = 8.83463e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000454118; expected ratio = 0.0001obtained abs = 0.117604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000466824 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.64984e-05; expected ratio = 1e-07obtained abs = 6.38445e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000344738; expected ratio = 0.0001obtained abs = 0.0892802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.900930e+05 Mflops = 5.80 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.25985e-05; expected ratio = 1e-07obtained abs = 4.8032e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000265024; expected ratio = 0.0001obtained abs = 0.0686373; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000472069 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.65399e-05; expected ratio = 1e-07obtained abs = 3.74074e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000204826; expected ratio = 0.0001obtained abs = 0.0530474; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000467777 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.52245e-05; expected ratio = 1e-07obtained abs = 2.9921e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000158866; expected ratio = 0.0001obtained abs = 0.0411448; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.68628e-05; expected ratio = 1e-07obtained abs = 2.43888e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000123758; expected ratio = 0.0001obtained abs = 0.0320522; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.00047183 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.900930e+05 Mflops = 17.41 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.04257e-05; expected ratio = 1e-07obtained abs = 2.01299e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.69617e-05; expected ratio = 0.0001obtained abs = 0.0251124; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000470877 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.900930e+05 Mflops = 8.70 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.53135e-05; expected ratio = 1e-07obtained abs = 1.67477e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.64844e-05; expected ratio = 0.0001obtained abs = 0.019809; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.11643e-05; expected ratio = 1e-07obtained abs = 1.40025e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.0771e-05; expected ratio = 0.0001obtained abs = 0.0157394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.77481e-05; expected ratio = 1e-07obtained abs = 1.17423e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.86349e-05; expected ratio = 0.0001obtained abs = 0.0125962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.900930e+05 Mflops = 17.41 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.49096e-05; expected ratio = 1e-07obtained abs = 9.86431e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.91869e-05; expected ratio = 0.0001obtained abs = 0.0101492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.73 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 145 - - Mesh vertices: 125 - Mesh triangles: 147 - Mesh edges: 238 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.73 -matrix_partition : [9](0,29,58,87,116,145,174,203,232) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0720966; expected ratio = 1e-07obtained abs = 0.000446508; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0407456; expected ratio = 0.0001obtained abs = 10.6557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00630868; expected ratio = 1e-07obtained abs = 3.8929e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0225951; expected ratio = 0.0001obtained abs = 5.95433; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000533104 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00262997; expected ratio = 1e-07obtained abs = 1.62247e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00397624; expected ratio = 0.0001obtained abs = 1.04896; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00146967; expected ratio = 1e-07obtained abs = 9.06649e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00203826; expected ratio = 0.0001obtained abs = 0.537802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000877947; expected ratio = 1e-07obtained abs = 5.41615e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00141268; expected ratio = 0.0001obtained abs = 0.372732; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000575287; expected ratio = 1e-07obtained abs = 3.54903e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00109246; expected ratio = 0.0001obtained abs = 0.28822; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513792 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000419791; expected ratio = 1e-07obtained abs = 2.58979e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000899964; expected ratio = 0.0001obtained abs = 0.237411; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000336036; expected ratio = 1e-07obtained abs = 2.0731e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000771308; expected ratio = 0.0001obtained abs = 0.203453; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00028599; expected ratio = 1e-07obtained abs = 1.76439e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000676311; expected ratio = 0.0001obtained abs = 0.178379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000251762; expected ratio = 1e-07obtained abs = 1.55324e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000600074; expected ratio = 0.0001obtained abs = 0.158258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000225304; expected ratio = 1e-07obtained abs = 1.39003e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000535299; expected ratio = 0.0001obtained abs = 0.141165; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000203024; expected ratio = 1e-07obtained abs = 1.25259e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000478401; expected ratio = 0.0001obtained abs = 0.126152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000183292; expected ratio = 1e-07obtained abs = 1.13086e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00042756; expected ratio = 0.0001obtained abs = 0.112739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000165354; expected ratio = 1e-07obtained abs = 1.02021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000381781; expected ratio = 0.0001obtained abs = 0.100663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000148862; expected ratio = 1e-07obtained abs = 9.18465e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000340452; expected ratio = 0.0001obtained abs = 0.0897621; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000527143 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133652; expected ratio = 1e-07obtained abs = 8.24625e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000303142; expected ratio = 0.0001obtained abs = 0.0799221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000119641; expected ratio = 1e-07obtained abs = 7.38188e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000269505; expected ratio = 0.0001obtained abs = 0.0710516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000106783; expected ratio = 1e-07obtained abs = 6.58857e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00023924; expected ratio = 0.0001obtained abs = 0.0630708; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.50363e-05; expected ratio = 1e-07obtained abs = 5.86387e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00021207; expected ratio = 0.0001obtained abs = 0.0559068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.43595e-05; expected ratio = 1e-07obtained abs = 5.20513e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000187737; expected ratio = 0.0001obtained abs = 0.049491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513792 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.47027e-05; expected ratio = 1e-07obtained abs = 4.60932e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000165994; expected ratio = 0.0001obtained abs = 0.0437583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.60092e-05; expected ratio = 1e-07obtained abs = 4.07293e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000146607; expected ratio = 0.0001obtained abs = 0.0386473; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.82164e-05; expected ratio = 1e-07obtained abs = 3.59212e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000129358; expected ratio = 0.0001obtained abs = 0.0340997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.12581e-05; expected ratio = 1e-07obtained abs = 3.16278e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000114038; expected ratio = 0.0001obtained abs = 0.030061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.50663e-05; expected ratio = 1e-07obtained abs = 2.78074e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100456; expected ratio = 0.0001obtained abs = 0.0264804; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.95734e-05; expected ratio = 1e-07obtained abs = 2.44182e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.84318e-05; expected ratio = 0.0001obtained abs = 0.0233107; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000535011 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.47132e-05; expected ratio = 1e-07obtained abs = 2.14194e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.78019e-05; expected ratio = 0.0001obtained abs = 0.0205085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.04229e-05; expected ratio = 1e-07obtained abs = 1.87721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.84154e-05; expected ratio = 0.0001obtained abs = 0.0180342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000511169 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.6643e-05; expected ratio = 1e-07obtained abs = 1.64398e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.01356e-05; expected ratio = 0.0001obtained abs = 0.0158516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.33184e-05; expected ratio = 1e-07obtained abs = 1.43884e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.28384e-05; expected ratio = 0.0001obtained abs = 0.013928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.03984e-05; expected ratio = 1e-07obtained abs = 1.25867e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.64122e-05; expected ratio = 0.0001obtained abs = 0.012234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.78369e-05; expected ratio = 1e-07obtained abs = 1.10061e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.07567e-05; expected ratio = 0.0001obtained abs = 0.0107433; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.55921e-05; expected ratio = 1e-07obtained abs = 9.62102e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.57824e-05; expected ratio = 0.0001obtained abs = 0.00943203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.74 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 125 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - - Mesh vertices: 125 - Mesh triangles: 193 - Mesh edges: 317 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 193 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - Input triangles: 147 - - Mesh vertices: 125 - Mesh triangles: 147 - Mesh edges: 238 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.74 -matrix_partition : [9](0,29,58,87,116,145,174,203,232) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0754052; expected ratio = 1e-07obtained abs = 0.000432905; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.060996; expected ratio = 0.0001obtained abs = 15.4188; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000585079 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00523338; expected ratio = 1e-07obtained abs = 2.99163e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0216144; expected ratio = 0.0001obtained abs = 5.48364; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000522137 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00165226; expected ratio = 1e-07obtained abs = 9.44115e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0022589; expected ratio = 0.0001obtained abs = 0.573267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00092376; expected ratio = 1e-07obtained abs = 5.27799e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00101859; expected ratio = 0.0001obtained abs = 0.258502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000558477; expected ratio = 1e-07obtained abs = 3.19078e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000663757; expected ratio = 0.0001obtained abs = 0.168447; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.02 -Solve flops = 2.187800e+04 Mflops = 1.31 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000358393; expected ratio = 1e-07obtained abs = 2.04758e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000476523; expected ratio = 0.0001obtained abs = 0.120928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000244053; expected ratio = 1e-07obtained abs = 1.39431e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000365437; expected ratio = 0.0001obtained abs = 0.0927358; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000175475; expected ratio = 1e-07obtained abs = 1.0025e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000294219; expected ratio = 0.0001obtained abs = 0.0746618; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000132027; expected ratio = 1e-07obtained abs = 7.54267e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000244677; expected ratio = 0.0001obtained abs = 0.062089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000102918; expected ratio = 1e-07obtained abs = 5.87966e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000207603; expected ratio = 0.0001obtained abs = 0.0526803; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00052619 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.23984e-05; expected ratio = 1e-07obtained abs = 4.70735e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000178308; expected ratio = 0.0001obtained abs = 0.0452462; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000512123 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.73056e-05; expected ratio = 1e-07obtained abs = 3.84509e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000154315; expected ratio = 0.0001obtained abs = 0.0391574; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.58242e-05; expected ratio = 1e-07obtained abs = 3.18916e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134217; expected ratio = 0.0001obtained abs = 0.0340573; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.68573e-05; expected ratio = 1e-07obtained abs = 2.67688e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000117146; expected ratio = 0.0001obtained abs = 0.0297253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.97076e-05; expected ratio = 1e-07obtained abs = 2.26842e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000102513; expected ratio = 0.0001obtained abs = 0.0260121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.39109e-05; expected ratio = 1e-07obtained abs = 1.93726e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.98927e-05; expected ratio = 0.0001obtained abs = 0.0228095; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000510216 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.91463e-05; expected ratio = 1e-07obtained abs = 1.66507e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.89588e-05; expected ratio = 0.0001obtained abs = 0.020035; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.51848e-05; expected ratio = 1e-07obtained abs = 1.43875e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.94535e-05; expected ratio = 0.0001obtained abs = 0.017623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.18587e-05; expected ratio = 1e-07obtained abs = 1.24874e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.11674e-05; expected ratio = 0.0001obtained abs = 0.0155205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.90429e-05; expected ratio = 1e-07obtained abs = 1.08788e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.39276e-05; expected ratio = 0.0001obtained abs = 0.0136834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.66422e-05; expected ratio = 1e-07obtained abs = 9.50728e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.759e-05; expected ratio = 0.0001obtained abs = 0.0120753; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.75 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 125 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - - Mesh vertices: 125 - Mesh triangles: 193 - Mesh edges: 317 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 193 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - Input triangles: 147 - - Mesh vertices: 125 - Mesh triangles: 147 - Mesh edges: 238 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.75 -matrix_partition : [9](0,29,58,87,116,145,174,203,232) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000517845 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0813058; expected ratio = 1e-07obtained abs = 0.000429705; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0384448; expected ratio = 0.0001obtained abs = 9.9616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00588336; expected ratio = 1e-07obtained abs = 3.09293e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.02127; expected ratio = 0.0001obtained abs = 5.52847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00148771; expected ratio = 1e-07obtained abs = 7.81709e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00202269; expected ratio = 0.0001obtained abs = 0.525786; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000834062; expected ratio = 1e-07obtained abs = 4.38217e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000834777; expected ratio = 0.0001obtained abs = 0.216983; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000516378; expected ratio = 1e-07obtained abs = 2.71297e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000515331; expected ratio = 0.0001obtained abs = 0.133944; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000338059; expected ratio = 1e-07obtained abs = 1.77608e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000344348; expected ratio = 0.0001obtained abs = 0.0895015; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000233441; expected ratio = 1e-07obtained abs = 1.22642e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000243513; expected ratio = 0.0001obtained abs = 0.0632926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000168972; expected ratio = 1e-07obtained abs = 8.87719e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000181223; expected ratio = 0.0001obtained abs = 0.0471027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000127069; expected ratio = 1e-07obtained abs = 6.67571e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000140667; expected ratio = 0.0001obtained abs = 0.0365619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.83967e-05; expected ratio = 1e-07obtained abs = 5.16936e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000112671; expected ratio = 0.0001obtained abs = 0.0292854; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.78871e-05; expected ratio = 1e-07obtained abs = 4.09186e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.22607e-05; expected ratio = 0.0001obtained abs = 0.0239804; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.26854e-05; expected ratio = 1e-07obtained abs = 3.29322e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.67133e-05; expected ratio = 0.0001obtained abs = 0.0199394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.11054e-05; expected ratio = 1e-07obtained abs = 2.68486e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.44852e-05; expected ratio = 0.0001obtained abs = 0.0167611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000648022 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.2098e-05; expected ratio = 1e-07obtained abs = 2.21164e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.46484e-05; expected ratio = 0.0001obtained abs = 0.0142043; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.49766e-05; expected ratio = 1e-07obtained abs = 1.83751e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.66067e-05; expected ratio = 0.0001obtained abs = 0.0121141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.92722e-05; expected ratio = 1e-07obtained abs = 1.53783e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.99528e-05; expected ratio = 0.0001obtained abs = 0.0103847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.46529e-05; expected ratio = 1e-07obtained abs = 1.29515e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.4395e-05; expected ratio = 0.0001obtained abs = 0.00894005; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.08771e-05; expected ratio = 1e-07obtained abs = 1.09679e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.97162e-05; expected ratio = 0.0001obtained abs = 0.00772393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.77654e-05; expected ratio = 1e-07obtained abs = 9.33311e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.57514e-05; expected ratio = 0.0001obtained abs = 0.00669337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.76 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 125 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - - Mesh vertices: 125 - Mesh triangles: 193 - Mesh edges: 317 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 193 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - Input triangles: 147 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.76 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0928094; expected ratio = 1e-07obtained abs = 0.000450945; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.035984; expected ratio = 0.0001obtained abs = 9.17568; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0102918; expected ratio = 1e-07obtained abs = 4.96203e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.025662; expected ratio = 0.0001obtained abs = 6.58544; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00362408; expected ratio = 1e-07obtained abs = 1.7456e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00318541; expected ratio = 0.0001obtained abs = 0.818253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00203122; expected ratio = 1e-07obtained abs = 9.78155e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00139525; expected ratio = 0.0001obtained abs = 0.358501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00125621; expected ratio = 1e-07obtained abs = 6.04881e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000961152; expected ratio = 0.0001obtained abs = 0.246994; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000820528; expected ratio = 1e-07obtained abs = 3.95074e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000731975; expected ratio = 0.0001obtained abs = 0.188121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000562043; expected ratio = 1e-07obtained abs = 2.70608e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000590191; expected ratio = 0.0001obtained abs = 0.151697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000607014 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000403628; expected ratio = 1e-07obtained abs = 1.94332e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000493404; expected ratio = 0.0001obtained abs = 0.126831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000303357; expected ratio = 1e-07obtained abs = 1.46054e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000421057; expected ratio = 0.0001obtained abs = 0.108243; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000237176; expected ratio = 1e-07obtained abs = 1.1419e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000363112; expected ratio = 0.0001obtained abs = 0.0933537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191211; expected ratio = 1e-07obtained abs = 9.20599e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000314685; expected ratio = 0.0001obtained abs = 0.0809088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000157578; expected ratio = 1e-07obtained abs = 7.5867e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000273296; expected ratio = 0.0001obtained abs = 0.0702714; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000131826; expected ratio = 1e-07obtained abs = 6.34688e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000237552; expected ratio = 0.0001obtained abs = 0.0610839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000111413; expected ratio = 1e-07obtained abs = 5.36408e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000206554; expected ratio = 0.0001obtained abs = 0.0531153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559807 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.48304e-05; expected ratio = 1e-07obtained abs = 4.5657e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000179634; expected ratio = 0.0001obtained abs = 0.0461946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000561953 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.11328e-05; expected ratio = 1e-07obtained abs = 3.90622e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000156252; expected ratio = 0.0001obtained abs = 0.0401831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.96892e-05; expected ratio = 1e-07obtained abs = 3.35527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000135947; expected ratio = 0.0001obtained abs = 0.0349624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.00523e-05; expected ratio = 1e-07obtained abs = 2.89129e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000118319; expected ratio = 0.0001obtained abs = 0.0304295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.18893e-05; expected ratio = 1e-07obtained abs = 2.49828e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103015; expected ratio = 0.0001obtained abs = 0.0264943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.49432e-05; expected ratio = 1e-07obtained abs = 2.16385e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.97295e-05; expected ratio = 0.0001obtained abs = 0.0230778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.90105e-05; expected ratio = 1e-07obtained abs = 1.87822e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.81933e-05; expected ratio = 0.0001obtained abs = 0.0201112; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.3927e-05; expected ratio = 1e-07obtained abs = 1.63347e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.81733e-05; expected ratio = 0.0001obtained abs = 0.0175343; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.95589e-05; expected ratio = 1e-07obtained abs = 1.42316e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.94668e-05; expected ratio = 0.0001obtained abs = 0.0152952; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.57959e-05; expected ratio = 1e-07obtained abs = 1.24198e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.18982e-05; expected ratio = 0.0001obtained abs = 0.0133486; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.25464e-05; expected ratio = 1e-07obtained abs = 1.08553e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.53155e-05; expected ratio = 0.0001obtained abs = 0.0116556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.97344e-05; expected ratio = 1e-07obtained abs = 9.50146e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.95874e-05; expected ratio = 0.0001obtained abs = 0.0101824; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.77 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.77 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0976634; expected ratio = 1e-07obtained abs = 0.00042883; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0359696; expected ratio = 0.0001obtained abs = 9.11847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00060606 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0104698; expected ratio = 1e-07obtained abs = 4.5568e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0255375; expected ratio = 0.0001obtained abs = 6.50852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00332411; expected ratio = 1e-07obtained abs = 1.44512e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00304771; expected ratio = 0.0001obtained abs = 0.777455; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00191799; expected ratio = 1e-07obtained abs = 8.33624e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00113371; expected ratio = 0.0001obtained abs = 0.289295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0012326; expected ratio = 1e-07obtained abs = 5.35673e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000749269; expected ratio = 0.0001obtained abs = 0.191234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000830901; expected ratio = 1e-07obtained abs = 3.61075e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000557128; expected ratio = 0.0001obtained abs = 0.142219; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000581951; expected ratio = 1e-07obtained abs = 2.52879e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000435798; expected ratio = 0.0001obtained abs = 0.111264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.02 -Solve flops = 2.275000e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000421891; expected ratio = 1e-07obtained abs = 1.83321e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000352982; expected ratio = 0.0001obtained abs = 0.090133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556231 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000315644; expected ratio = 1e-07obtained abs = 1.37151e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000292823; expected ratio = 0.0001obtained abs = 0.0747808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000242831; expected ratio = 1e-07obtained abs = 1.05511e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000246606; expected ratio = 0.0001obtained abs = 0.0629846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191266; expected ratio = 1e-07obtained abs = 8.31049e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000209536; expected ratio = 0.0001obtained abs = 0.0535217; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000153547; expected ratio = 1e-07obtained abs = 6.67156e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000178948; expected ratio = 0.0001obtained abs = 0.0457123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000125121; expected ratio = 1e-07obtained abs = 5.43642e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000153282; expected ratio = 0.0001obtained abs = 0.0391587; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00010314; expected ratio = 1e-07obtained abs = 4.48135e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131549; expected ratio = 0.0001obtained abs = 0.0336085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.57832e-05; expected ratio = 1e-07obtained abs = 3.72718e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113057; expected ratio = 0.0001obtained abs = 0.0288855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.18484e-05; expected ratio = 1e-07obtained abs = 3.12172e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.72827e-05; expected ratio = 0.0001obtained abs = 0.0248563; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000609875 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.05169e-05; expected ratio = 1e-07obtained abs = 2.62937e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.38069e-05; expected ratio = 0.0001obtained abs = 0.0214139; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.12105e-05; expected ratio = 1e-07obtained abs = 2.22502e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.22826e-05; expected ratio = 0.0001obtained abs = 0.0184698; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.35076e-05; expected ratio = 1e-07obtained abs = 1.89034e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.24178e-05; expected ratio = 0.0001obtained abs = 0.0159496; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.70923e-05; expected ratio = 1e-07obtained abs = 1.6116e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.39653e-05; expected ratio = 0.0001obtained abs = 0.01379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.17222e-05; expected ratio = 1e-07obtained abs = 1.37828e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.67151e-05; expected ratio = 0.0001obtained abs = 0.0119376; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000566006 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.72075e-05; expected ratio = 1e-07obtained abs = 1.18212e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.04891e-05; expected ratio = 0.0001obtained abs = 0.0103467; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.33979e-05; expected ratio = 1e-07obtained abs = 1.0166e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.5136e-05; expected ratio = 0.0001obtained abs = 0.00897889; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.01726e-05; expected ratio = 1e-07obtained abs = 8.76464e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.05277e-05; expected ratio = 0.0001obtained abs = 0.00780134; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.78 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.78 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.105443; expected ratio = 1e-07obtained abs = 0.000414532; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.032447; expected ratio = 0.0001obtained abs = 8.28543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0119013; expected ratio = 1e-07obtained abs = 4.62601e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0254423; expected ratio = 0.0001obtained abs = 6.53195; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00060606 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00256088; expected ratio = 1e-07obtained abs = 9.93846e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00332815; expected ratio = 0.0001obtained abs = 0.855027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00134047; expected ratio = 1e-07obtained abs = 5.20081e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00106271; expected ratio = 0.0001obtained abs = 0.273035; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000894195; expected ratio = 1e-07obtained abs = 3.46908e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000664112; expected ratio = 0.0001obtained abs = 0.170623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000629055; expected ratio = 1e-07obtained abs = 2.44036e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000480022; expected ratio = 0.0001obtained abs = 0.123325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000459967; expected ratio = 1e-07obtained abs = 1.78435e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000360982; expected ratio = 0.0001obtained abs = 0.0927416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000573874 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0003479; expected ratio = 1e-07obtained abs = 1.34958e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000278354; expected ratio = 0.0001obtained abs = 0.0715133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000270808; expected ratio = 1e-07obtained abs = 1.05051e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000219377; expected ratio = 0.0001obtained abs = 0.0563615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000215805; expected ratio = 1e-07obtained abs = 8.37136e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000176327; expected ratio = 0.0001obtained abs = 0.0453012; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000775099 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000175195; expected ratio = 1e-07obtained abs = 6.79596e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000144171; expected ratio = 0.0001obtained abs = 0.03704; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559807 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000144278; expected ratio = 1e-07obtained abs = 5.59664e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000119587; expected ratio = 0.0001obtained abs = 0.0307238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000602007 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000120119; expected ratio = 1e-07obtained abs = 4.65949e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100364; expected ratio = 0.0001obtained abs = 0.0257852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000100835; expected ratio = 1e-07obtained abs = 3.91141e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.50255e-05; expected ratio = 0.0001obtained abs = 0.0218444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.276800e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.51771e-05; expected ratio = 1e-07obtained abs = 3.30405e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.25679e-05; expected ratio = 0.0001obtained abs = 0.0186438; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.2296e-05; expected ratio = 1e-07obtained abs = 2.80438e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.22991e-05; expected ratio = 0.0001obtained abs = 0.0160055; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.15903e-05; expected ratio = 1e-07obtained abs = 2.3891e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.37309e-05; expected ratio = 0.0001obtained abs = 0.0138042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.26229e-05; expected ratio = 1e-07obtained abs = 2.04125e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.65106e-05; expected ratio = 0.0001obtained abs = 0.0119491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.50657e-05; expected ratio = 1e-07obtained abs = 1.7481e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.03771e-05; expected ratio = 0.0001obtained abs = 0.0103733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.86669e-05; expected ratio = 1e-07obtained abs = 1.49989e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.51332e-05; expected ratio = 0.0001obtained abs = 0.00902606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.32287e-05; expected ratio = 1e-07obtained abs = 1.28894e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.06263e-05; expected ratio = 0.0001obtained abs = 0.00786817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.0005548 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.85932e-05; expected ratio = 1e-07obtained abs = 1.10913e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.67367e-05; expected ratio = 0.0001obtained abs = 0.00686884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.46323e-05; expected ratio = 1e-07obtained abs = 9.55488e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.33683e-05; expected ratio = 0.0001obtained abs = 0.00600345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.79 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.79 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.117394; expected ratio = 1e-07obtained abs = 0.000407569; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0325809; expected ratio = 0.0001obtained abs = 8.28593; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0152065; expected ratio = 1e-07obtained abs = 5.20166e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0273544; expected ratio = 0.0001obtained abs = 6.98076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000565052 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00289278; expected ratio = 1e-07obtained abs = 9.8721e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00386401; expected ratio = 0.0001obtained abs = 0.986947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00118637; expected ratio = 1e-07obtained abs = 4.04706e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00110773; expected ratio = 0.0001obtained abs = 0.282962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000772506; expected ratio = 1e-07obtained abs = 2.63501e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000638409; expected ratio = 0.0001obtained abs = 0.163072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000658035 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000547397; expected ratio = 1e-07obtained abs = 1.8671e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000449536; expected ratio = 0.0001obtained abs = 0.114823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000561953 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000403625; expected ratio = 1e-07obtained abs = 1.37669e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000332497; expected ratio = 0.0001obtained abs = 0.0849255; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000307989; expected ratio = 1e-07obtained abs = 1.05048e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000252541; expected ratio = 0.0001obtained abs = 0.0645018; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0002421; expected ratio = 1e-07obtained abs = 8.25737e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000196227; expected ratio = 0.0001obtained abs = 0.0501176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000195042; expected ratio = 1e-07obtained abs = 6.65227e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000155838; expected ratio = 0.0001obtained abs = 0.0398013; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000160235; expected ratio = 1e-07obtained abs = 5.4651e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126352; expected ratio = 0.0001obtained abs = 0.0322701; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133658; expected ratio = 1e-07obtained abs = 4.55861e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104391; expected ratio = 0.0001obtained abs = 0.0266609; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000112796; expected ratio = 1e-07obtained abs = 3.84709e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.76668e-05; expected ratio = 0.0001obtained abs = 0.0223894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.60427e-05; expected ratio = 1e-07obtained abs = 3.27567e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.46304e-05; expected ratio = 0.0001obtained abs = 0.0190598; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.23363e-05; expected ratio = 1e-07obtained abs = 2.80819e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.42324e-05; expected ratio = 0.0001obtained abs = 0.016404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.09569e-05; expected ratio = 1e-07obtained abs = 2.42007e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.57597e-05; expected ratio = 0.0001obtained abs = 0.0142401; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.13994e-05; expected ratio = 1e-07obtained abs = 2.0941e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.87242e-05; expected ratio = 0.0001obtained abs = 0.0124432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.3299e-05; expected ratio = 1e-07obtained abs = 1.81783e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.27877e-05; expected ratio = 0.0001obtained abs = 0.010927; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.0005548 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.63844e-05; expected ratio = 1e-07obtained abs = 1.58199e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.77123e-05; expected ratio = 0.0001obtained abs = 0.00963079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.04485e-05; expected ratio = 1e-07obtained abs = 1.37954e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.33272e-05; expected ratio = 0.0001obtained abs = 0.00851088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000617027 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.533e-05; expected ratio = 1e-07obtained abs = 1.20497e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.95075e-05; expected ratio = 0.0001obtained abs = 0.00753537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.276800e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.09004e-05; expected ratio = 1e-07obtained abs = 1.05389e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.61595e-05; expected ratio = 0.0001obtained abs = 0.00668033; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.837690e+05 Mflops = 17.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.70558e-05; expected ratio = 1e-07obtained abs = 9.22765e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.3211e-05; expected ratio = 0.0001obtained abs = 0.00592734; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.8 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.132125; expected ratio = 1e-07obtained abs = 0.000398074; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.035272; expected ratio = 0.0001obtained abs = 8.95556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0199718; expected ratio = 1e-07obtained abs = 5.90032e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.02908; expected ratio = 0.0001obtained abs = 7.42026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000612974 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00392232; expected ratio = 1e-07obtained abs = 1.15459e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00546536; expected ratio = 0.0001obtained abs = 1.39583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00119763; expected ratio = 1e-07obtained abs = 3.52291e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00110256; expected ratio = 0.0001obtained abs = 0.281653; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000691466; expected ratio = 1e-07obtained abs = 2.03369e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000519881; expected ratio = 0.0001obtained abs = 0.132805; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000562191 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000484021; expected ratio = 1e-07obtained abs = 1.42351e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000350142; expected ratio = 0.0001obtained abs = 0.0894417; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000355119; expected ratio = 1e-07obtained abs = 1.04439e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000258552; expected ratio = 0.0001obtained abs = 0.0660431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00056386 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000269106; expected ratio = 1e-07obtained abs = 7.91416e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000197627; expected ratio = 0.0001obtained abs = 0.0504792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.276800e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00020997; expected ratio = 1e-07obtained abs = 6.17499e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000154613; expected ratio = 0.0001obtained abs = 0.0394913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000689983 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000168113; expected ratio = 1e-07obtained abs = 4.94396e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000123546; expected ratio = 0.0001obtained abs = 0.0315554; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000137574; expected ratio = 1e-07obtained abs = 4.04583e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100766; expected ratio = 0.0001obtained abs = 0.0257365; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000114619; expected ratio = 1e-07obtained abs = 3.37075e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.37942e-05; expected ratio = 0.0001obtained abs = 0.0214014; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.68776e-05; expected ratio = 1e-07obtained abs = 2.84899e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.09105e-05; expected ratio = 0.0001obtained abs = 0.0181106; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000620842 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.28207e-05; expected ratio = 1e-07obtained abs = 2.4356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.09162e-05; expected ratio = 0.0001obtained abs = 0.0155578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.1442e-05; expected ratio = 1e-07obtained abs = 2.10097e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.29807e-05; expected ratio = 0.0001obtained abs = 0.0135309; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.20637e-05; expected ratio = 1e-07obtained abs = 1.82517e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.65311e-05; expected ratio = 0.0001obtained abs = 0.0118835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.42182e-05; expected ratio = 1e-07obtained abs = 1.59445e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.11733e-05; expected ratio = 0.0001obtained abs = 0.0105151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.75747e-05; expected ratio = 1e-07obtained abs = 1.39907e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.66359e-05; expected ratio = 0.0001obtained abs = 0.0093562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.18931e-05; expected ratio = 1e-07obtained abs = 1.23199e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.27305e-05; expected ratio = 0.0001obtained abs = 0.00835874; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.69952e-05; expected ratio = 1e-07obtained abs = 1.08795e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.93252e-05; expected ratio = 0.0001obtained abs = 0.00748901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.27455e-05; expected ratio = 1e-07obtained abs = 9.62972e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.63258e-05; expected ratio = 0.0001obtained abs = 0.00672298; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.81 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.81 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.151073; expected ratio = 1e-07obtained abs = 0.000386008; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0382462; expected ratio = 0.0001obtained abs = 9.68623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0271019; expected ratio = 1e-07obtained abs = 6.74278e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0309163; expected ratio = 0.0001obtained abs = 7.87524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00602558; expected ratio = 1e-07obtained abs = 1.49038e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00588436; expected ratio = 0.0001obtained abs = 1.50088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00159788; expected ratio = 1e-07obtained abs = 3.94699e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00138772; expected ratio = 0.0001obtained abs = 0.354045; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000698169; expected ratio = 1e-07obtained abs = 1.72404e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000477457; expected ratio = 0.0001obtained abs = 0.121813; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000457102; expected ratio = 1e-07obtained abs = 1.12867e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000281842; expected ratio = 0.0001obtained abs = 0.0719028; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000331755; expected ratio = 1e-07obtained abs = 8.19141e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000210285; expected ratio = 0.0001obtained abs = 0.0536447; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000248842; expected ratio = 1e-07obtained abs = 6.14411e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000166633; expected ratio = 0.0001obtained abs = 0.042507; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191397; expected ratio = 1e-07obtained abs = 4.7257e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134946; expected ratio = 0.0001obtained abs = 0.0344225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000150737; expected ratio = 1e-07obtained abs = 3.72176e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000110782; expected ratio = 0.0001obtained abs = 0.0282577; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000121348; expected ratio = 1e-07obtained abs = 2.99613e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.20205e-05; expected ratio = 0.0001obtained abs = 0.0234713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.0005548 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.96246e-05; expected ratio = 1e-07obtained abs = 2.45976e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.72907e-05; expected ratio = 0.0001obtained abs = 0.0197137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000620127 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.31899e-05; expected ratio = 1e-07obtained abs = 2.05397e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.56073e-05; expected ratio = 0.0001obtained abs = 0.0167333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.04687e-05; expected ratio = 1e-07obtained abs = 1.73988e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.62394e-05; expected ratio = 0.0001obtained abs = 0.0143437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.837690e+05 Mflops = 17.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.04061e-05; expected ratio = 1e-07obtained abs = 1.49143e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.86412e-05; expected ratio = 0.0001obtained abs = 0.0124056; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.22869e-05; expected ratio = 1e-07obtained abs = 1.29097e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.24041e-05; expected ratio = 0.0001obtained abs = 0.0108147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.56193e-05; expected ratio = 1e-07obtained abs = 1.12634e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.72218e-05; expected ratio = 0.0001obtained abs = 0.00949287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.276800e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.00589e-05; expected ratio = 1e-07obtained abs = 9.89054e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.28645e-05; expected ratio = 0.0001obtained abs = 0.00838151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.82 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.82 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000586987 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.175861; expected ratio = 1e-07obtained abs = 0.000369327; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0439743; expected ratio = 0.0001obtained abs = 11.1394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.024430e+05 Mflops = 6.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0380047; expected ratio = 1e-07obtained abs = 7.6902e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0330025; expected ratio = 0.0001obtained abs = 8.40895; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0100735; expected ratio = 1e-07obtained abs = 2.01832e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00761752; expected ratio = 0.0001obtained abs = 1.94376; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000603914 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00290193; expected ratio = 1e-07obtained abs = 5.7985e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00208575; expected ratio = 0.0001obtained abs = 0.532368; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00102276; expected ratio = 1e-07obtained abs = 2.04207e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000696659; expected ratio = 0.0001obtained abs = 0.177813; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.025990e+05 Mflops = 6.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000528564; expected ratio = 1e-07obtained abs = 1.0551e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000354704; expected ratio = 0.0001obtained abs = 0.0905271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.025990e+05 Mflops = 18.16 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000353779; expected ratio = 1e-07obtained abs = 7.06147e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000250666; expected ratio = 0.0001obtained abs = 0.0639699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000257492; expected ratio = 1e-07obtained abs = 5.1394e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000195803; expected ratio = 0.0001obtained abs = 0.0499659; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000592947 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000193649; expected ratio = 1e-07obtained abs = 3.86508e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000157098; expected ratio = 0.0001obtained abs = 0.0400868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.030430e+05 Mflops = 6.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000149054; expected ratio = 1e-07obtained abs = 2.97498e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000127585; expected ratio = 0.0001obtained abs = 0.0325548; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.030430e+05 Mflops = 9.09 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000117142; expected ratio = 1e-07obtained abs = 2.33802e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104533; expected ratio = 0.0001obtained abs = 0.026672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.38371e-05; expected ratio = 1e-07obtained abs = 1.87288e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.62972e-05; expected ratio = 0.0001obtained abs = 0.0220184; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.64744e-05; expected ratio = 1e-07obtained abs = 1.52634e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.17351e-05; expected ratio = 0.0001obtained abs = 0.0183025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.030430e+05 Mflops = 9.09 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.32798e-05; expected ratio = 1e-07obtained abs = 1.26298e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.00177e-05; expected ratio = 0.0001obtained abs = 0.0153127; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000594854 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.030430e+05 Mflops = 6.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.30599e-05; expected ratio = 1e-07obtained abs = 1.05901e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.05279e-05; expected ratio = 0.0001obtained abs = 0.0128913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.50023e-05; expected ratio = 1e-07obtained abs = 8.98185e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.27976e-05; expected ratio = 0.0001obtained abs = 0.0109189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.83 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.83 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.666130e+05 Mflops = 16.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.209678; expected ratio = 1e-07obtained abs = 0.000346064; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0505647; expected ratio = 0.0001obtained abs = 12.7643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0551022; expected ratio = 1e-07obtained abs = 8.6208e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0359786; expected ratio = 0.0001obtained abs = 9.12415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.017725; expected ratio = 1e-07obtained abs = 2.72525e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102703; expected ratio = 0.0001obtained abs = 2.60984; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00604008; expected ratio = 1e-07obtained abs = 9.23244e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00330312; expected ratio = 0.0001obtained abs = 0.84006; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00217345; expected ratio = 1e-07obtained abs = 3.31555e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114811; expected ratio = 0.0001obtained abs = 0.292101; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000884902; expected ratio = 1e-07obtained abs = 1.34897e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000496888; expected ratio = 0.0001obtained abs = 0.126442; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000457914; expected ratio = 1e-07obtained abs = 6.97892e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000317163; expected ratio = 0.0001obtained abs = 0.0807173; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.228600e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000299688; expected ratio = 1e-07obtained abs = 4.56708e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000250778; expected ratio = 0.0001obtained abs = 0.0638276; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000220675; expected ratio = 1e-07obtained abs = 3.36287e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000207716; expected ratio = 0.0001obtained abs = 0.0528706; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00017018; expected ratio = 1e-07obtained abs = 2.59335e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000173277; expected ratio = 0.0001obtained abs = 0.0441069; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000594139 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000134185; expected ratio = 1e-07obtained abs = 2.04482e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000144888; expected ratio = 0.0001obtained abs = 0.0368819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000107364; expected ratio = 1e-07obtained abs = 1.6361e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000121459; expected ratio = 0.0001obtained abs = 0.030919; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.02 -Solve flops = 2.228600e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.69162e-05; expected ratio = 1e-07obtained abs = 1.3245e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000102122; expected ratio = 0.0001obtained abs = 0.0259972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.10852e-05; expected ratio = 1e-07obtained abs = 1.08325e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.61327e-05; expected ratio = 0.0001obtained abs = 0.0219273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.86788e-05; expected ratio = 1e-07obtained abs = 8.94195e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.28735e-05; expected ratio = 0.0001obtained abs = 0.0185522; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.84 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.84 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000561953 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.258472; expected ratio = 1e-07obtained abs = 0.000313056; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0602813; expected ratio = 0.0001obtained abs = 15.2023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0852578; expected ratio = 1e-07obtained abs = 9.5156e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0376707; expected ratio = 0.0001obtained abs = 9.56198; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.034306; expected ratio = 1e-07obtained abs = 3.70217e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0129927; expected ratio = 0.0001obtained abs = 3.30713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000595093 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0146385; expected ratio = 1e-07obtained abs = 1.55704e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00515392; expected ratio = 0.0001obtained abs = 1.3134; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00641826; expected ratio = 1e-07obtained abs = 6.78372e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00214111; expected ratio = 0.0001obtained abs = 0.545897; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00287096; expected ratio = 1e-07obtained abs = 3.02593e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000930405; expected ratio = 0.0001obtained abs = 0.237259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.0116692 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00132458; expected ratio = 1e-07obtained abs = 1.39433e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000455914; expected ratio = 0.0001obtained abs = 0.116268; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00102401 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000654655; expected ratio = 1e-07obtained abs = 6.88742e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000281987; expected ratio = 0.0001obtained abs = 0.0719125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00099802 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000369508; expected ratio = 1e-07obtained abs = 3.8865e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000212121; expected ratio = 0.0001obtained abs = 0.0540941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000994921 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000245901; expected ratio = 1e-07obtained abs = 2.58609e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000171673; expected ratio = 0.0001obtained abs = 0.0437781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00107908 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000184333; expected ratio = 1e-07obtained abs = 1.93849e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000141043; expected ratio = 0.0001obtained abs = 0.0359665; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000969887 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000146313; expected ratio = 1e-07obtained abs = 1.53863e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000116043; expected ratio = 0.0001obtained abs = 0.0295908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000940084 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000118902; expected ratio = 1e-07obtained abs = 1.25035e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.55005e-05; expected ratio = 0.0001obtained abs = 0.0243521; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000981092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.76646e-05; expected ratio = 1e-07obtained abs = 1.02702e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.87026e-05; expected ratio = 0.0001obtained abs = 0.0200685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000919104 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.07378e-05; expected ratio = 1e-07obtained abs = 8.49018e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.50183e-05; expected ratio = 0.0001obtained abs = 0.0165789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.85 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.85 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00100088 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.337023; expected ratio = 1e-07obtained abs = 0.000265146; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.07234; expected ratio = 0.0001obtained abs = 18.2238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000915051 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.143738; expected ratio = 1e-07obtained abs = 9.88799e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0373433; expected ratio = 0.0001obtained abs = 9.47585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000926971 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0744312; expected ratio = 1e-07obtained abs = 4.76612e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.016092; expected ratio = 0.0001obtained abs = 4.09816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000916958 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0413922; expected ratio = 1e-07obtained abs = 2.54545e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00814681; expected ratio = 0.0001obtained abs = 2.07891; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000928879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0238885; expected ratio = 1e-07obtained abs = 1.43492e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00439927; expected ratio = 0.0001obtained abs = 1.12391; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000936031 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.014093; expected ratio = 1e-07obtained abs = 8.34842e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00247531; expected ratio = 0.0001obtained abs = 0.632813; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000920057 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00843782; expected ratio = 1e-07obtained abs = 4.95697e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00144007; expected ratio = 0.0001obtained abs = 0.368301; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000927925 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0051107; expected ratio = 1e-07obtained abs = 2.98735e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000868081; expected ratio = 0.0001obtained abs = 0.222066; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000936031 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00312938; expected ratio = 1e-07obtained abs = 1.82364e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00054693; expected ratio = 0.0001obtained abs = 0.139931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000911951 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00193962; expected ratio = 1e-07obtained abs = 1.1282e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000363763; expected ratio = 0.0001obtained abs = 0.0930759; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000897884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00122073; expected ratio = 1e-07obtained abs = 7.09236e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000256349; expected ratio = 0.0001obtained abs = 0.0655952; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00089407 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00078405; expected ratio = 1e-07obtained abs = 4.55203e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000190181; expected ratio = 0.0001obtained abs = 0.0486653; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000929117 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000517277; expected ratio = 1e-07obtained abs = 3.00187e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000146617; expected ratio = 0.0001obtained abs = 0.0375183; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000934839 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000352961; expected ratio = 1e-07obtained abs = 2.04773e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000115938; expected ratio = 0.0001obtained abs = 0.0296683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000989914 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000250324; expected ratio = 1e-07obtained abs = 1.45202e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.31447e-05; expected ratio = 0.0001obtained abs = 0.0238356; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000941038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000184693; expected ratio = 1e-07obtained abs = 1.0712e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.55849e-05; expected ratio = 0.0001obtained abs = 0.0193422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000931978 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000141254; expected ratio = 1e-07obtained abs = 8.19196e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.17505e-05; expected ratio = 0.0001obtained abs = 0.015802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.86 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.86 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000939846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.479353; expected ratio = 1e-07obtained abs = 0.000188009; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0945785; expected ratio = 0.0001obtained abs = 23.8569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000945091 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.276519; expected ratio = 1e-07obtained abs = 8.49849e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0308112; expected ratio = 0.0001obtained abs = 7.83084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.187928; expected ratio = 1e-07obtained abs = 4.86449e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0167068; expected ratio = 0.0001obtained abs = 4.26419; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000669003 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.13748; expected ratio = 1e-07obtained abs = 3.13058e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010309; expected ratio = 0.0001obtained abs = 2.63967; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.104983; expected ratio = 1e-07obtained abs = 2.16509e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00706341; expected ratio = 0.0001obtained abs = 1.81322; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0824768; expected ratio = 1e-07obtained abs = 1.57261e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00520731; expected ratio = 0.0001obtained abs = 1.33951; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0661077; expected ratio = 1e-07obtained abs = 1.18331e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0040288; expected ratio = 0.0001obtained abs = 1.03813; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0537765; expected ratio = 1e-07obtained abs = 9.14199e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0032154; expected ratio = 0.0001obtained abs = 0.829707; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00060606 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0446227; expected ratio = 1e-07obtained abs = 7.26756e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00450709; expected ratio = 0.0001obtained abs = 1.16479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000636816 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0369133; expected ratio = 1e-07obtained abs = 5.80224e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00218068; expected ratio = 0.0001obtained abs = 0.564148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0308253; expected ratio = 1e-07obtained abs = 4.70358e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0018265; expected ratio = 0.0001obtained abs = 0.472921; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.656890e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0258954; expected ratio = 1e-07obtained abs = 3.85395e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00153189; expected ratio = 0.0001obtained abs = 0.396926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000627041 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0218527; expected ratio = 1e-07obtained abs = 3.18449e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00129167; expected ratio = 0.0001obtained abs = 0.33489; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0185082; expected ratio = 1e-07obtained abs = 2.64941e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00109401; expected ratio = 0.0001obtained abs = 0.283792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.656890e+05 Mflops = 15.94 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.015722; expected ratio = 1e-07obtained abs = 2.2167e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000929816; expected ratio = 0.0001obtained abs = 0.241308; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.227400e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0133876; expected ratio = 1e-07obtained abs = 1.86334e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000792372; expected ratio = 0.0001obtained abs = 0.205718; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000565052 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0114224; expected ratio = 1e-07obtained abs = 1.57239e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000676631; expected ratio = 0.0001obtained abs = 0.175727; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00976159; expected ratio = 1e-07obtained abs = 1.33118e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000578722; expected ratio = 0.0001obtained abs = 0.150342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00835352; expected ratio = 1e-07obtained abs = 1.13001e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000495609; expected ratio = 0.0001obtained abs = 0.128782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.656890e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00715652; expected ratio = 1e-07obtained abs = 9.61431e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000424865; expected ratio = 0.0001obtained abs = 0.110422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0061367; expected ratio = 1e-07obtained abs = 8.19558e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000364518; expected ratio = 0.0001obtained abs = 0.0947549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00526624; expected ratio = 1e-07obtained abs = 6.99744e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000312953; expected ratio = 0.0001obtained abs = 0.0813632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552177 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00452213; expected ratio = 1e-07obtained abs = 5.98255e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00026883; expected ratio = 0.0001obtained abs = 0.0699012; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.227400e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00388522; expected ratio = 1e-07obtained abs = 5.12072e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000231033; expected ratio = 0.0001obtained abs = 0.06008; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00333949; expected ratio = 1e-07obtained abs = 4.38729e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000198625; expected ratio = 0.0001obtained abs = 0.0516573; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00287148; expected ratio = 1e-07obtained abs = 3.76199e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000170817; expected ratio = 0.0001obtained abs = 0.0444288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000638008 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00246982; expected ratio = 1e-07obtained abs = 3.22807e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00014694; expected ratio = 0.0001obtained abs = 0.0382213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00212489; expected ratio = 1e-07obtained abs = 2.77155e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126429; expected ratio = 0.0001obtained abs = 0.032888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655330e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00182853; expected ratio = 1e-07obtained abs = 2.3808e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000108801; expected ratio = 0.0001obtained abs = 0.0283039; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00157379; expected ratio = 1e-07obtained abs = 2.04601e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.3645e-05; expected ratio = 0.0001obtained abs = 0.0243624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000566006 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00135474; expected ratio = 1e-07obtained abs = 1.75894e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.06113e-05; expected ratio = 0.0001obtained abs = 0.0209724; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00116634; expected ratio = 1e-07obtained abs = 1.51262e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.93996e-05; expected ratio = 0.0001obtained abs = 0.0180561; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655330e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00100424; expected ratio = 1e-07obtained abs = 1.30113e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.97529e-05; expected ratio = 0.0001obtained abs = 0.0155467; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00086475; expected ratio = 1e-07obtained abs = 1.11947e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.14514e-05; expected ratio = 0.0001obtained abs = 0.0133871; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000744692; expected ratio = 1e-07obtained abs = 9.63353e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.43064e-05; expected ratio = 0.0001obtained abs = 0.0115283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.87 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.87 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559807 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.686003; expected ratio = 1e-07obtained abs = 5.27592e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121806; expected ratio = 0.0001obtained abs = 31.0969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.492299; expected ratio = 1e-07obtained abs = 2.54953e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0140715; expected ratio = 0.0001obtained abs = 3.61825; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.341288; expected ratio = 1e-07obtained abs = 1.3263e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142153; expected ratio = 0.0001obtained abs = 3.67679; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000852108 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.653950e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.266419; expected ratio = 1e-07obtained abs = 8.20161e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0133973; expected ratio = 0.0001obtained abs = 3.47902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.185683; expected ratio = 1e-07obtained abs = 4.84181e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00987867; expected ratio = 0.0001obtained abs = 2.57511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0984862; expected ratio = 1e-07obtained abs = 2.35238e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0110378; expected ratio = 0.0001obtained abs = 2.87701; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543833 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0502969; expected ratio = 1e-07obtained abs = 1.14825e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0063797; expected ratio = 0.0001obtained abs = 1.66504; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.653950e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0193803; expected ratio = 1e-07obtained abs = 4.34936e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00326747; expected ratio = 0.0001obtained abs = 0.853627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00669953; expected ratio = 1e-07obtained abs = 1.49436e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00111293; expected ratio = 0.0001obtained abs = 0.290916; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000609159 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00252076; expected ratio = 1e-07obtained abs = 5.60982e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000425314; expected ratio = 0.0001obtained abs = 0.1112; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.88 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.88 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000642061 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.145589; expected ratio = 1e-07obtained abs = 3.76293e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0401793; expected ratio = 0.0001obtained abs = 10.5726; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000594854 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0560639; expected ratio = 1e-07obtained abs = 1.52635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119746; expected ratio = 0.0001obtained abs = 3.14367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0285828; expected ratio = 1e-07obtained abs = 7.98791e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00521839; expected ratio = 0.0001obtained abs = 1.36937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0167856; expected ratio = 1e-07obtained abs = 4.76149e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00310829; expected ratio = 0.0001obtained abs = 0.815613; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00749561; expected ratio = 1e-07obtained abs = 2.1409e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00132722; expected ratio = 0.0001obtained abs = 0.348168; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00060606 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00895925; expected ratio = 1e-07obtained abs = 2.57746e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00300073; expected ratio = 0.0001obtained abs = 0.787941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00415465; expected ratio = 1e-07obtained abs = 1.19966e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000788494; expected ratio = 0.0001obtained abs = 0.207076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00202022; expected ratio = 1e-07obtained abs = 5.84413e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000338992; expected ratio = 0.0001obtained abs = 0.0890265; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.89 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.89 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0856961; expected ratio = 1e-07obtained abs = 2.2925e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0204922; expected ratio = 0.0001obtained abs = 5.35931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0273766; expected ratio = 1e-07obtained abs = 7.14418e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00458183; expected ratio = 0.0001obtained abs = 1.19988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0118723; expected ratio = 1e-07obtained abs = 3.06476e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00195919; expected ratio = 0.0001obtained abs = 0.513378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00988574; expected ratio = 1e-07obtained abs = 2.531e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00252638; expected ratio = 0.0001obtained abs = 0.661562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.008023; expected ratio = 1e-07obtained abs = 2.04157e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00189938; expected ratio = 0.0001obtained abs = 0.49721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00260319; expected ratio = 1e-07obtained abs = 6.60873e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00043759; expected ratio = 0.0001obtained abs = 0.114562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.9 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000582933 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0448081; expected ratio = 1e-07obtained abs = 1.18711e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115464; expected ratio = 0.0001obtained abs = 3.02975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.013447; expected ratio = 1e-07obtained abs = 3.60692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00262845; expected ratio = 0.0001obtained abs = 0.689066; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000573158 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00573108; expected ratio = 1e-07obtained abs = 1.54539e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00109284; expected ratio = 0.0001obtained abs = 0.286385; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0024818; expected ratio = 1e-07obtained abs = 6.7075e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00046787; expected ratio = 0.0001obtained abs = 0.122586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.91 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.91 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0262012; expected ratio = 1e-07obtained abs = 6.91424e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00673473; expected ratio = 0.0001obtained abs = 1.76212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00775671; expected ratio = 1e-07obtained abs = 2.03259e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00150275; expected ratio = 0.0001obtained abs = 0.393393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542164 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00323848; expected ratio = 1e-07obtained abs = 8.46119e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000609782; expected ratio = 0.0001obtained abs = 0.159664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.92 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.92 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543833 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0143629; expected ratio = 1e-07obtained abs = 3.80197e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00395756; expected ratio = 0.0001obtained abs = 1.03713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00416461; expected ratio = 1e-07obtained abs = 1.10657e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000842215; expected ratio = 0.0001obtained abs = 0.220652; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00175402; expected ratio = 1e-07obtained abs = 4.66804e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000340524; expected ratio = 0.0001obtained abs = 0.0892034; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.93 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.93 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000594139 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00861528; expected ratio = 1e-07obtained abs = 2.27532e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00233436; expected ratio = 0.0001obtained abs = 0.611192; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000690937 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0025; expected ratio = 1e-07obtained abs = 6.58775e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000509505; expected ratio = 0.0001obtained abs = 0.133423; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.94 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.94 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000642061 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00454228; expected ratio = 1e-07obtained abs = 1.20166e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00141914; expected ratio = 0.0001obtained abs = 0.371756; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000546217 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00123102; expected ratio = 1e-07obtained abs = 3.26023e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000262091; expected ratio = 0.0001obtained abs = 0.068651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.95 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.95 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00288522; expected ratio = 1e-07obtained abs = 7.62231e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000851342; expected ratio = 0.0001obtained abs = 0.222951; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.96 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.96 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00132235; expected ratio = 1e-07obtained abs = 3.49718e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000556731; expected ratio = 0.0001obtained abs = 0.14582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.97 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.97 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00104227; expected ratio = 1e-07obtained abs = 2.75405e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000332136; expected ratio = 0.0001obtained abs = 0.0869859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.98 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.98 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000545636; expected ratio = 1e-07obtained abs = 1.44238e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000216045; expected ratio = 0.0001obtained abs = 0.0565853; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.99 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.99 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000565052 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000402073; expected ratio = 1e-07obtained abs = 1.06252e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000130311; expected ratio = 0.0001obtained abs = 0.0341287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.0 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000212558; expected ratio = 1e-07obtained abs = 5.61795e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.5309e-05; expected ratio = 0.0001obtained abs = 0.0223432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -line49 -Estimating delta time -1.01 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.01 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000164901; expected ratio = 1e-07obtained abs = 4.35777e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.10174e-05; expected ratio = 0.0001obtained abs = 0.0133616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.02 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.02 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.77724e-05; expected ratio = 1e-07obtained abs = 2.05537e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.4953e-05; expected ratio = 0.0001obtained abs = 0.00915437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.03 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.03 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.48127e-05; expected ratio = 1e-07obtained abs = 1.97703e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.0476e-05; expected ratio = 0.0001obtained abs = 0.00536273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.04 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.04 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.74368e-05; expected ratio = 1e-07obtained abs = 7.25062e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.61066e-05; expected ratio = 0.0001obtained abs = 0.00421838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.05 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.05 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.09162e-05; expected ratio = 1e-07obtained abs = 1.08124e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.97371e-06; expected ratio = 0.0001obtained abs = 0.00261213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.06 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.06 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543833 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.70324e-05; expected ratio = 1e-07obtained abs = 4.5009e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.86017e-06; expected ratio = 0.0001obtained abs = 0.00258238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.07 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.07 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.87241e-05; expected ratio = 1e-07obtained abs = 7.59033e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.59279e-06; expected ratio = 0.0001obtained abs = 0.00198855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.08 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.08 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.90593e-05; expected ratio = 1e-07obtained abs = 5.03633e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.16075e-06; expected ratio = 0.0001obtained abs = 0.00213729; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.09 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.09 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.4482e-05; expected ratio = 1e-07obtained abs = 6.46914e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.37574e-06; expected ratio = 0.0001obtained abs = 0.00193169; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.1 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000546217 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.07762e-05; expected ratio = 1e-07obtained abs = 5.48982e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.72187e-06; expected ratio = 0.0001obtained abs = 0.00202233; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.11 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.11 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559807 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2977e-05; expected ratio = 1e-07obtained abs = 6.07125e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.43255e-06; expected ratio = 0.0001obtained abs = 0.00194655; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.12 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.12 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.15533e-05; expected ratio = 1e-07obtained abs = 5.69495e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.59213e-06; expected ratio = 0.0001obtained abs = 0.00198834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.13 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.13 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.24214e-05; expected ratio = 1e-07obtained abs = 5.92423e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.47853e-06; expected ratio = 0.0001obtained abs = 0.00195858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.14 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.14 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547171 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.18704e-05; expected ratio = 1e-07obtained abs = 5.77853e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.54701e-06; expected ratio = 0.0001obtained abs = 0.00197651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.15 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.15 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000541925 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.22099e-05; expected ratio = 1e-07obtained abs = 5.86815e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50076e-06; expected ratio = 0.0001obtained abs = 0.00196439; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.16 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.16 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.19954e-05; expected ratio = 1e-07obtained abs = 5.81137e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.52945e-06; expected ratio = 0.0001obtained abs = 0.00197189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.17 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.17 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.21276e-05; expected ratio = 1e-07obtained abs = 5.84621e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51021e-06; expected ratio = 0.0001obtained abs = 0.00196685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.18 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.18 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20436e-05; expected ratio = 1e-07obtained abs = 5.82391e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.52208e-06; expected ratio = 0.0001obtained abs = 0.00196995; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.19 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.19 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000782967 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20949e-05; expected ratio = 1e-07obtained abs = 5.83735e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51392e-06; expected ratio = 0.0001obtained abs = 0.0019678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.2 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000631094 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20617e-05; expected ratio = 1e-07obtained abs = 5.82847e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51873e-06; expected ratio = 0.0001obtained abs = 0.00196906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.21 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.21 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20813e-05; expected ratio = 1e-07obtained abs = 5.83354e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51515e-06; expected ratio = 0.0001obtained abs = 0.00196811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.22 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.22 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20679e-05; expected ratio = 1e-07obtained abs = 5.8299e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51702e-06; expected ratio = 0.0001obtained abs = 0.00196859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.23 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.23 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20751e-05; expected ratio = 1e-07obtained abs = 5.83171e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51536e-06; expected ratio = 0.0001obtained abs = 0.00196815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.24 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.24 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000541925 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20694e-05; expected ratio = 1e-07obtained abs = 5.83011e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51598e-06; expected ratio = 0.0001obtained abs = 0.00196831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.25 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.25 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20718e-05; expected ratio = 1e-07obtained abs = 5.83064e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51513e-06; expected ratio = 0.0001obtained abs = 0.00196808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.26 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.26 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000581026 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20692e-05; expected ratio = 1e-07obtained abs = 5.82984e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51523e-06; expected ratio = 0.0001obtained abs = 0.0019681; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.27 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.27 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20697e-05; expected ratio = 1e-07obtained abs = 5.82987e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51471e-06; expected ratio = 0.0001obtained abs = 0.00196795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.28 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.28 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000602961 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20682e-05; expected ratio = 1e-07obtained abs = 5.82938e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.5146e-06; expected ratio = 0.0001obtained abs = 0.00196792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.29 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.29 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000586033 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2068e-05; expected ratio = 1e-07obtained abs = 5.82922e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51422e-06; expected ratio = 0.0001obtained abs = 0.00196781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.3 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2067e-05; expected ratio = 1e-07obtained abs = 5.82885e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51402e-06; expected ratio = 0.0001obtained abs = 0.00196775; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.31 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.31 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20664e-05; expected ratio = 1e-07obtained abs = 5.82861e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.5137e-06; expected ratio = 0.0001obtained abs = 0.00196766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.32 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.32 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000583172 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20656e-05; expected ratio = 1e-07obtained abs = 5.82829e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51345e-06; expected ratio = 0.0001obtained abs = 0.00196759; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.33 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.33 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00189996 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2065e-05; expected ratio = 1e-07obtained abs = 5.82802e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51316e-06; expected ratio = 0.0001obtained abs = 0.0019675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.34 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.34 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20642e-05; expected ratio = 1e-07obtained abs = 5.82772e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.5129e-06; expected ratio = 0.0001obtained abs = 0.00196743; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.35 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.35 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20635e-05; expected ratio = 1e-07obtained abs = 5.82744e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51262e-06; expected ratio = 0.0001obtained abs = 0.00196735; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.36 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.36 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20628e-05; expected ratio = 1e-07obtained abs = 5.82714e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51235e-06; expected ratio = 0.0001obtained abs = 0.00196727; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.37 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.37 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000541925 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20621e-05; expected ratio = 1e-07obtained abs = 5.82686e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51208e-06; expected ratio = 0.0001obtained abs = 0.00196719; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.38 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.38 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000692129 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20614e-05; expected ratio = 1e-07obtained abs = 5.82656e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51181e-06; expected ratio = 0.0001obtained abs = 0.00196711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.39 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.39 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20607e-05; expected ratio = 1e-07obtained abs = 5.82628e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51153e-06; expected ratio = 0.0001obtained abs = 0.00196703; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.4 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.206e-05; expected ratio = 1e-07obtained abs = 5.82599e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51126e-06; expected ratio = 0.0001obtained abs = 0.00196695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.41 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.41 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20593e-05; expected ratio = 1e-07obtained abs = 5.8257e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51099e-06; expected ratio = 0.0001obtained abs = 0.00196687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.42 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.42 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20586e-05; expected ratio = 1e-07obtained abs = 5.82541e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51071e-06; expected ratio = 0.0001obtained abs = 0.00196679; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.43 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.43 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20579e-05; expected ratio = 1e-07obtained abs = 5.82512e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51044e-06; expected ratio = 0.0001obtained abs = 0.00196672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.44 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.44 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000730991 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20571e-05; expected ratio = 1e-07obtained abs = 5.82483e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51017e-06; expected ratio = 0.0001obtained abs = 0.00196664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.45 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.45 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547171 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20564e-05; expected ratio = 1e-07obtained abs = 5.82454e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50989e-06; expected ratio = 0.0001obtained abs = 0.00196656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.46 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.46 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00068903 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20557e-05; expected ratio = 1e-07obtained abs = 5.82425e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50962e-06; expected ratio = 0.0001obtained abs = 0.00196648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.47 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.47 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2055e-05; expected ratio = 1e-07obtained abs = 5.82397e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50935e-06; expected ratio = 0.0001obtained abs = 0.0019664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.48 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.48 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000603914 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20543e-05; expected ratio = 1e-07obtained abs = 5.82368e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50908e-06; expected ratio = 0.0001obtained abs = 0.00196632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.49 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.49 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000541925 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20536e-05; expected ratio = 1e-07obtained abs = 5.82339e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.5088e-06; expected ratio = 0.0001obtained abs = 0.00196624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.5 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20529e-05; expected ratio = 1e-07obtained abs = 5.8231e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50853e-06; expected ratio = 0.0001obtained abs = 0.00196616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.init b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.init deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.lin b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.lin deleted file mode 100644 index 923256460cd6..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.lin and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.mdpa b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.mdpa deleted file mode 100644 index 7923659de674..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.mdpa +++ /dev/null @@ -1,776 +0,0 @@ -Begin ModelPartData -// VARIABLE_NAME value -End ModelPartData - -Begin Properties 0 -End Properties - - -Begin Nodes -1 2.50000 2.00000 0.00000 -2 2.50000 1.88235 0.00000 -3 2.50000 1.76471 0.00000 -4 2.50000 1.64706 0.00000 -5 2.50000 1.52941 0.00000 -6 2.50000 1.41176 0.00000 -7 2.50000 1.29412 0.00000 -8 2.50000 1.17647 0.00000 -9 2.50000 1.05882 0.00000 -10 2.50000 0.94118 0.00000 -11 2.50000 0.82353 0.00000 -12 2.50000 0.70588 0.00000 -13 2.50000 0.58824 0.00000 -14 2.50000 0.47059 0.00000 -15 2.50000 0.35294 0.00000 -16 2.50000 0.23529 0.00000 -17 1.00000 1.00000 0.00000 -18 1.00000 0.87500 0.00000 -19 2.50000 0.11765 0.00000 -20 0.87500 1.00000 0.00000 -21 1.00000 0.75000 0.00000 -22 0.86295 0.86251 0.00000 -23 2.50000 0.00000 0.00000 -24 2.38462 0.00000 0.00000 -25 2.26923 0.00000 0.00000 -26 0.75000 1.00000 0.00000 -27 2.15385 0.00000 0.00000 -28 1.00000 0.62500 0.00000 -29 2.03846 0.00000 0.00000 -30 1.92308 0.00000 0.00000 -31 0.82861 0.74553 0.00000 -32 1.80769 0.00000 0.00000 -33 1.00000 0.50000 0.00000 -34 0.73505 0.82130 0.00000 -35 0.62500 1.00000 0.00000 -36 1.69231 0.00000 0.00000 -37 0.82226 0.62502 0.00000 -38 0.62269 0.89175 0.00000 -39 1.57692 0.00000 0.00000 -40 0.72528 0.68452 0.00000 -41 1.00000 0.37500 0.00000 -42 0.50000 1.00000 0.00000 -43 0.83096 0.50554 0.00000 -44 1.46154 0.00000 0.00000 -45 0.62078 0.74350 0.00000 -46 0.72646 0.56452 0.00000 -47 1.00000 0.25000 0.00000 -48 1.34615 0.00000 0.00000 -49 0.51627 0.80248 0.00000 -50 0.83213 0.38555 0.00000 -51 0.62195 0.62350 0.00000 -52 0.37500 1.00000 0.00000 -53 0.72763 0.44453 0.00000 -54 1.23077 0.00000 0.00000 -55 0.85927 0.28008 0.00000 -56 0.40332 0.87747 0.00000 -57 0.51745 0.68248 0.00000 -58 0.62280 0.50368 0.00000 -59 1.00000 0.12500 0.00000 -60 1.11538 0.00000 0.00000 -61 0.41294 0.74147 0.00000 -62 0.72880 0.32453 0.00000 -63 0.30726 0.92044 0.00000 -64 0.51818 0.56245 0.00000 -65 0.25000 1.00000 0.00000 -66 0.86471 0.14085 0.00000 -67 0.62419 0.38366 0.00000 -68 0.30844 0.80045 0.00000 -69 1.00000 0.00000 0.00000 -70 0.00000 2.00000 0.00000 -71 0.41412 0.62147 0.00000 -72 0.00000 1.87500 0.00000 -73 0.00000 1.75000 0.00000 -74 0.51959 0.44246 0.00000 -75 0.72998 0.20454 0.00000 -76 0.00000 1.62500 0.00000 -77 0.00000 1.50000 0.00000 -78 0.62547 0.26352 0.00000 -79 0.30961 0.68045 0.00000 -80 0.41498 0.50122 0.00000 -81 0.18495 0.87601 0.00000 -82 0.87500 0.00000 0.00000 -83 0.12500 1.00000 0.00000 -84 0.00000 1.37500 0.00000 -85 0.52096 0.32249 0.00000 -86 0.00000 1.25000 0.00000 -87 0.20428 0.73872 0.00000 -88 0.31034 0.55997 0.00000 -89 0.41641 0.38123 0.00000 -90 0.00000 1.12500 0.00000 -91 0.75000 0.00000 0.00000 -92 0.62543 0.11176 0.00000 -93 0.52214 0.20251 0.00000 -94 0.20571 0.61873 0.00000 -95 0.09965 0.79748 0.00000 -96 0.31178 0.43998 0.00000 -97 0.00000 1.00000 0.00000 -98 0.41768 0.26154 0.00000 -99 0.10108 0.67749 0.00000 -100 0.20714 0.49874 0.00000 -101 0.62500 0.00000 0.00000 -102 0.00000 0.87500 0.00000 -103 0.31321 0.31999 0.00000 -104 0.00000 0.75000 0.00000 -105 0.10251 0.55750 0.00000 -106 0.20864 0.37873 0.00000 -107 0.40765 0.12402 0.00000 -108 0.50000 0.00000 0.00000 -109 0.31466 0.20000 0.00000 -110 0.00000 0.62500 0.00000 -111 0.10392 0.43750 0.00000 -112 0.21003 0.25875 0.00000 -113 0.31640 0.08009 0.00000 -114 0.00000 0.50000 0.00000 -115 0.37500 0.00000 0.00000 -116 0.10552 0.31719 0.00000 -117 0.22053 0.12269 0.00000 -118 0.00000 0.37500 0.00000 -119 0.10705 0.19727 0.00000 -120 0.25000 0.00000 0.00000 -121 0.00000 0.25000 0.00000 -122 0.12500 0.00000 0.00000 -123 0.00000 0.12500 0.00000 -124 0.00000 0.00000 0.00000 -End Nodes - -Begin Elements NoNewtonianASGS2D -1 0 17 20 18 -2 0 97 102 83 -3 0 124 122 123 -4 0 69 59 82 -5 0 114 118 111 -6 0 111 118 116 -7 0 116 118 121 -8 0 111 116 106 -9 0 111 106 100 -10 0 111 100 105 -11 0 105 100 94 -12 0 94 100 88 -13 0 88 100 96 -14 0 88 96 80 -15 0 80 96 89 -16 0 89 96 103 -17 0 103 96 106 -18 0 103 106 112 -19 0 106 96 100 -20 0 103 112 109 -21 0 112 106 116 -22 0 112 116 119 -23 0 119 116 121 -24 0 119 121 123 -25 0 112 119 117 -26 0 117 119 122 -27 0 112 117 109 -28 0 109 117 113 -29 0 109 113 107 -30 0 113 117 120 -31 0 113 120 115 -32 0 113 115 107 -33 0 109 107 98 -34 0 109 98 103 -35 0 103 98 89 -36 0 89 98 85 -37 0 89 85 74 -38 0 85 98 93 -39 0 89 74 80 -40 0 93 98 107 -41 0 93 107 108 -42 0 85 93 78 -43 0 74 85 67 -44 0 80 74 64 -45 0 78 93 92 -46 0 64 74 58 -47 0 92 93 108 -48 0 58 74 67 -49 0 111 105 114 -50 0 114 105 110 -51 0 67 85 78 -52 0 78 92 75 -53 0 75 92 91 -54 0 78 75 62 -55 0 62 75 55 -56 0 78 62 67 -57 0 55 75 66 -58 0 55 66 47 -59 0 66 75 91 -60 0 62 55 50 -61 0 62 50 53 -62 0 50 55 41 -63 0 53 50 43 -64 0 43 50 33 -65 0 53 43 46 -66 0 46 43 37 -67 0 53 46 58 -68 0 46 37 40 -69 0 43 33 28 -70 0 43 28 37 -71 0 40 37 31 -72 0 46 40 51 -73 0 51 40 45 -74 0 40 31 34 -75 0 45 40 34 -76 0 37 28 31 -77 0 28 21 31 -78 0 34 31 22 -79 0 34 22 26 -80 0 31 21 22 -81 0 21 18 22 -82 0 45 34 38 -83 0 45 38 49 -84 0 45 49 57 -85 0 57 49 61 -86 0 57 61 71 -87 0 71 61 79 -88 0 79 61 68 -89 0 68 61 56 -90 0 68 56 63 -91 0 63 56 52 -92 0 63 52 65 -93 0 63 65 81 -94 0 81 65 83 -95 0 63 81 68 -96 0 61 49 56 -97 0 56 49 42 -98 0 38 34 26 -99 0 49 38 42 -100 0 62 53 67 -101 0 51 45 57 -102 0 51 57 64 -103 0 71 79 88 -104 0 94 88 79 -105 0 46 51 58 -106 0 58 51 64 -107 0 105 94 99 -108 0 105 99 110 -109 0 110 99 104 -110 0 99 94 87 -111 0 99 87 95 -112 0 95 87 81 -113 0 99 95 104 -114 0 104 95 102 -115 0 87 94 79 -116 0 80 64 71 -117 0 71 64 57 -118 0 79 68 87 -119 0 88 80 71 -120 0 67 53 58 -121 0 87 68 81 -122 0 81 83 102 -123 0 42 52 56 -124 0 108 101 92 -125 0 26 35 38 -126 0 47 41 55 -127 0 91 82 66 -128 0 59 47 66 -129 0 122 120 117 -130 0 20 26 22 -131 0 101 91 92 -132 0 35 42 38 -133 0 115 108 107 -134 0 41 33 50 -135 0 102 95 81 -136 0 119 123 122 -137 0 20 22 18 -138 0 66 82 59 -End Elements - - -Begin Conditions Condition2D -139 0 69 82 -140 0 82 91 -141 0 91 101 -142 0 101 108 -143 0 108 115 -144 0 115 120 -145 0 120 122 -146 0 122 124 -147 0 17 18 -148 0 18 21 -149 0 21 28 -150 0 28 33 -151 0 33 41 -152 0 41 47 -153 0 47 59 -154 0 59 69 -155 0 97 83 -156 0 83 65 -157 0 65 52 -158 0 52 42 -159 0 42 35 -160 0 35 26 -161 0 26 20 -162 0 20 17 -163 0 124 123 -164 0 123 121 -165 0 121 118 -166 0 118 114 -167 0 114 110 -168 0 110 104 -169 0 104 102 -170 0 102 97 -End Conditions - - -Begin NodalData DISPLACEMENT_X -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -19 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -27 1 0.000000 -29 1 0.000000 -30 1 0.000000 -32 1 0.000000 -36 1 0.000000 -39 1 0.000000 -44 1 0.000000 -48 1 0.000000 -54 1 0.000000 -60 1 0.000000 -69 1 0.000000 -70 1 0.000000 -72 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -82 1 0.000000 -84 1 0.000000 -86 1 0.000000 -90 1 0.000000 -91 1 0.000000 -97 1 0.000000 -101 1 0.000000 -102 1 0.000000 -104 1 0.000000 -108 1 0.000000 -110 1 0.000000 -114 1 0.000000 -115 1 0.000000 -118 1 0.000000 -120 1 0.000000 -121 1 0.000000 -122 1 0.000000 -123 1 0.000000 -124 1 0.000000 -End NodalData - -Begin NodalData DISPLACEMENT_Y -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -19 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -27 1 0.000000 -29 1 0.000000 -30 1 0.000000 -32 1 0.000000 -36 1 0.000000 -39 1 0.000000 -44 1 0.000000 -48 1 0.000000 -54 1 0.000000 -60 1 0.000000 -69 1 0.000000 -70 1 0.000000 -72 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -82 1 0.000000 -84 1 0.000000 -86 1 0.000000 -90 1 0.000000 -91 1 0.000000 -97 1 0.000000 -101 1 0.000000 -102 1 0.000000 -104 1 0.000000 -108 1 0.000000 -110 1 0.000000 -114 1 0.000000 -115 1 0.000000 -118 1 0.000000 -120 1 0.000000 -121 1 0.000000 -122 1 0.000000 -123 1 0.000000 -124 1 0.000000 -End NodalData - -Begin NodalData DISPLACEMENT_Z -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -19 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -27 1 0.000000 -29 1 0.000000 -30 1 0.000000 -32 1 0.000000 -36 1 0.000000 -39 1 0.000000 -44 1 0.000000 -48 1 0.000000 -54 1 0.000000 -60 1 0.000000 -69 1 0.000000 -70 1 0.000000 -72 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -82 1 0.000000 -84 1 0.000000 -86 1 0.000000 -90 1 0.000000 -91 1 0.000000 -97 1 0.000000 -101 1 0.000000 -102 1 0.000000 -104 1 0.000000 -108 1 0.000000 -110 1 0.000000 -114 1 0.000000 -115 1 0.000000 -118 1 0.000000 -120 1 0.000000 -121 1 0.000000 -122 1 0.000000 -123 1 0.000000 -124 1 0.000000 -End NodalData - -Begin NodalData VELOCITY_X -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -19 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -27 1 0.000000 -29 1 0.000000 -30 1 0.000000 -32 1 0.000000 -36 1 0.000000 -39 1 0.000000 -44 1 0.000000 -48 1 0.000000 -54 1 0.000000 -60 1 0.000000 -69 1 0.000000 -70 1 0.000000 -72 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -82 1 0.000000 -84 1 0.000000 -86 1 0.000000 -90 1 0.000000 -91 1 0.000000 -97 1 0.000000 -101 1 0.000000 -102 1 0.000000 -104 1 0.000000 -108 1 0.000000 -110 1 0.000000 -114 1 0.000000 -115 1 0.000000 -118 1 0.000000 -120 1 0.000000 -121 1 0.000000 -122 1 0.000000 -123 1 0.000000 -124 1 0.000000 -End NodalData - -Begin NodalData VELOCITY_Y -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -19 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -27 1 0.000000 -29 1 0.000000 -30 1 0.000000 -32 1 0.000000 -36 1 0.000000 -39 1 0.000000 -44 1 0.000000 -48 1 0.000000 -54 1 0.000000 -60 1 0.000000 -69 1 0.000000 -70 1 0.000000 -72 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -82 1 0.000000 -84 1 0.000000 -86 1 0.000000 -90 1 0.000000 -91 1 0.000000 -97 1 0.000000 -101 1 0.000000 -102 1 0.000000 -104 1 0.000000 -108 1 0.000000 -110 1 0.000000 -114 1 0.000000 -115 1 0.000000 -118 1 0.000000 -120 1 0.000000 -121 1 0.000000 -122 1 0.000000 -123 1 0.000000 -124 1 0.000000 -End NodalData - -Begin NodalData VELOCITY_Z -1 1 0.000000 -2 1 0.000000 -3 1 0.000000 -4 1 0.000000 -5 1 0.000000 -6 1 0.000000 -7 1 0.000000 -8 1 0.000000 -9 1 0.000000 -10 1 0.000000 -11 1 0.000000 -12 1 0.000000 -13 1 0.000000 -14 1 0.000000 -15 1 0.000000 -16 1 0.000000 -19 1 0.000000 -23 1 0.000000 -24 1 0.000000 -25 1 0.000000 -27 1 0.000000 -29 1 0.000000 -30 1 0.000000 -32 1 0.000000 -36 1 0.000000 -39 1 0.000000 -44 1 0.000000 -48 1 0.000000 -54 1 0.000000 -60 1 0.000000 -69 1 0.000000 -70 1 0.000000 -72 1 0.000000 -73 1 0.000000 -76 1 0.000000 -77 1 0.000000 -82 1 0.000000 -84 1 0.000000 -86 1 0.000000 -90 1 0.000000 -91 1 0.000000 -97 1 0.000000 -101 1 0.000000 -102 1 0.000000 -104 1 0.000000 -108 1 0.000000 -110 1 0.000000 -114 1 0.000000 -115 1 0.000000 -118 1 0.000000 -120 1 0.000000 -121 1 0.000000 -122 1 0.000000 -123 1 0.000000 -124 1 0.000000 -End NodalData - -Begin NodalData IS_BOUNDARY -17 1 1.000000 -18 1 1.000000 -20 1 1.000000 -21 1 1.000000 -26 1 1.000000 -28 1 1.000000 -33 1 1.000000 -35 1 1.000000 -41 1 1.000000 -42 1 1.000000 -47 1 1.000000 -52 1 1.000000 -59 1 1.000000 -65 1 1.000000 -69 1 1.000000 -82 1 1.000000 -83 1 1.000000 -91 1 1.000000 -97 1 1.000000 -101 1 1.000000 -102 1 1.000000 -104 1 1.000000 -108 1 1.000000 -110 1 1.000000 -114 1 1.000000 -115 1 1.000000 -118 1 1.000000 -120 1 1.000000 -121 1 1.000000 -122 1 1.000000 -123 1 1.000000 -124 1 1.000000 -End NodalData - -Begin NodalData IS_FREE_SURFACE -17 0 1.000000 -18 0 1.000000 -20 0 1.000000 -21 0 1.000000 -26 0 1.000000 -28 0 1.000000 -33 0 1.000000 -35 0 1.000000 -41 0 1.000000 -42 0 1.000000 -47 0 1.000000 -52 0 1.000000 -59 0 1.000000 -65 0 1.000000 -69 0 1.000000 -83 0 1.000000 -97 0 1.000000 -End NodalData - -Begin NodalData IS_STRUCTURE -1 0 1.000000 -2 0 1.000000 -3 0 1.000000 -4 0 1.000000 -5 0 1.000000 -6 0 1.000000 -7 0 1.000000 -8 0 1.000000 -9 0 1.000000 -10 0 1.000000 -11 0 1.000000 -12 0 1.000000 -13 0 1.000000 -14 0 1.000000 -15 0 1.000000 -16 0 1.000000 -19 0 1.000000 -23 0 1.000000 -24 0 1.000000 -25 0 1.000000 -27 0 1.000000 -29 0 1.000000 -30 0 1.000000 -32 0 1.000000 -36 0 1.000000 -39 0 1.000000 -44 0 1.000000 -48 0 1.000000 -54 0 1.000000 -60 0 1.000000 -69 0 1.000000 -70 0 1.000000 -72 0 1.000000 -73 0 1.000000 -76 0 1.000000 -77 0 1.000000 -82 0 1.000000 -84 0 1.000000 -86 0 1.000000 -90 0 1.000000 -91 0 1.000000 -97 0 1.000000 -101 0 1.000000 -102 0 1.000000 -104 0 1.000000 -108 0 1.000000 -110 0 1.000000 -114 0 1.000000 -115 0 1.000000 -118 0 1.000000 -120 0 1.000000 -121 0 1.000000 -122 0 1.000000 -123 0 1.000000 -124 0 1.000000 -End NodalData - - - diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.msh b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.msh deleted file mode 100644 index 6d825b8ed331..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.msh and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.node b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.node deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.png b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.png deleted file mode 100644 index 3e7c2fe75301..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.png and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.prb b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.prb deleted file mode 100644 index 4af218f4beee..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.prb +++ /dev/null @@ -1,61 +0,0 @@ -PROBLEM DATA -BOOK: Problem Parameters -QUESTION: Python_script_file#CB#(Use_Default,Do_not_write,Copy_From,Use_Current) -VALUE: Use_Default -DEPENDENCIES: (Use_Default,SET,Python_file,#CURRENT#)(Do_not_write,SET,Python_file,#CURRENT#)(Copy_From,RESTORE,Python_file,#CURRENT#)(Use_Current,SET,Python_file,#CURRENT#) -QUESTION: Python_file -VALUE: script.py -TKWIDGET: TkwidgetFilePath -QUESTION: Transfer_materials_to_lower_entities#CB#(1,0) -VALUE: 1 -QUESTION: Let_GiD_determine_domain_size#CB#(1,0) -VALUE: 1 -DEPENDENCIES: (1,HIDE,DOMAIN_SIZE,#CURRENT#)(0,RESTORE,DOMAIN_SIZE,#CURRENT#) -QUESTION: DOMAIN_SIZE#CB#(2,3) -VALUE: 2 -STATE: HIDDEN -QUESTION: Density -VALUE: 1000.0 -QUESTION: Viscosity -VALUE: 0.000001 -QUESTION: Gravity_X -VALUE: 0.0 -QUESTION: Gravity_Y -VALUE: -9.806 -QUESTION: Gravity_Z -VALUE: 0.0 -QUESTION: YieldStress -VALUE: 1500.0 -QUESTION: max_x -VALUE: 2.5 -QUESTION: max_y -VALUE: 3.0 -QUESTION: max_z -VALUE: 1.0 -QUESTION: min_x -VALUE: -1.0 -QUESTION: min_y -VALUE: -1.0 -QUESTION: min_z -VALUE: -1.0 -QUESTION: use_oss -VALUE: 0 -QUESTION: dynamic_tau -VALUE: 1 -QUESTION: nsteps -VALUE: 150 -QUESTION: output_dt -VALUE: 0.5 -QUESTION: min_dt -VALUE: 0.01 -QUESTION: max_dt -VALUE: 0.1 -QUESTION: safety_factor -VALUE: 0.1 -QUESTION: SolverType#CB#(pfem_solver_ale,monolithic_solver_lagrangian) -VALUE: monolithic_solver_lagrangian -QUESTION: laplacian_form -VALUE: 3 -END PROBLEM DATA -INTERVAL DATA -END INTERVAL DATA diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.prop b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.prop deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.py b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.py deleted file mode 100644 index fce462a23d2f..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.py +++ /dev/null @@ -1,141 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# import the configuration data as read from the GiD -import pfem_nonewtonian_var - -# -# -# setting the domain size for the problem to be solved -domain_size = pfem_nonewtonian_var.domain_size - -# -# -# ATTENTION: here the order is important - -# including kratos path -import sys -sys.path.append(pfem_nonewtonian_var.kratos_path) - -# importing Kratos main library -from KratosMultiphysics import * - -# importing applications -from KratosMultiphysics.StructuralApplication import * -from KratosMultiphysics.IncompressibleFluidApplication import * -# from now on the order is not anymore crucial -# -# - -# defining a model part -model_part = ModelPart("FluidPart") - -# importing the solver files and adding the variables -SolverType = pfem_nonewtonian_var.SolverType - -if(SolverType == "pfem_solver_ale"): - import pfem_solver_ale - pfem_solver_ale.AddVariables(model_part) -elif(SolverType == "monolithic_solver_lagrangian"): - import monolithic_solver_lagrangian_nonnewtonian - monolithic_solver_lagrangian_nonnewtonian.AddVariables(model_part) -else: - raise "solver type not supported: options are FractionalStep - Monolithic" - - -# reading a model -name = pfem_nonewtonian_var.problem_name - -gid_mode = GiDPostMode.GiD_PostBinary -multifile = MultiFileFlag.MultipleFiles -deformed_mesh_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteElementsOnly -gid_io = GidIO(name, gid_mode, multifile, deformed_mesh_flag, write_conditions) -model_part_io = ModelPartIO(name) -model_part_io.ReadModelPart(model_part) - -# check to ensure that no node has zero density or pressure -for node in model_part.Nodes: - node.SetSolutionStepValue(DENSITY, 0, pfem_nonewtonian_var.Density) - node.SetSolutionStepValue(VISCOSITY, 0, pfem_nonewtonian_var.Viscosity) - node.SetSolutionStepValue(BODY_FORCE_X, 0, pfem_nonewtonian_var.Gravity_X) - node.SetSolutionStepValue(BODY_FORCE_Y, 0, pfem_nonewtonian_var.Gravity_Y) - node.SetSolutionStepValue(BODY_FORCE_Z, 0, pfem_nonewtonian_var.Gravity_Z) - node.SetSolutionStepValue(YIELD_STRESS, 0, pfem_nonewtonian_var.YieldStress) -# if(node.GetSolutionStepValue(DENSITY) == 0.0): -# print "node ",node.Id," has zero density!" -# raise 'node with zero density found' -# if(node.GetSolutionStepValue(VISCOSITY) == 0.0): -# print "node ",node.Id," has zero viscosity!" -# raise 'node with zero density found' - - -mesh_name = 0.0 -gid_io.InitializeMesh(mesh_name) -gid_io.WriteMesh((model_part).GetMesh()) -gid_io.FinalizeMesh() - -print(model_part) -print(model_part.Properties) - -# setting the limits of the bounding box -box_corner1 = Vector(3) -box_corner1[0] = pfem_nonewtonian_var.min_x -box_corner1[1] = pfem_nonewtonian_var.min_y -box_corner1[2] = pfem_nonewtonian_var.min_z -box_corner2 = Vector(3) -box_corner2[0] = pfem_nonewtonian_var.max_x; -box_corner2[1] = pfem_nonewtonian_var.max_y; -box_corner2[2] = pfem_nonewtonian_var.max_z; - -# time setting -output_Dt = pfem_nonewtonian_var.output_Dt -max_dt = pfem_nonewtonian_var.max_dt -min_dt = pfem_nonewtonian_var.min_dt -safety_factor = pfem_nonewtonian_var.safety_factor -nsteps = pfem_nonewtonian_var.nsteps - -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(2) - -if(SolverType == "pfem_solver_ale"): - # adding dofs - pfem_solver_ale.AddDofs(model_part) - # creating a fluid solver object - name = str("dam2d") - solver = pfem_solver_ale.PFEMSolver(model_part, name, box_corner1, box_corner2, domain_size) - solver.laplacian_form = pfem_nonewtonian_var.laplacian_form - solver.echo_level = 0 - solver.prediction_order = 1 - solver.predictor_corrector = True - solver.smooth = True - solver.alpha_shape = 1.2 - solver.max_press_its = 3; - # initializing the solver - initial_dt = 0.001 * min_dt - solver.Initialize(initial_dt, output_Dt) -elif(SolverType == "monolithic_solver_lagrangian"): - # adding dofs - monolithic_solver_lagrangian_nonnewtonian.AddDofs(model_part) - solver = monolithic_solver_lagrangian_nonnewtonian.MonolithicSolver(model_part, domain_size, box_corner1, box_corner2) - oss_swith = pfem_nonewtonian_var.use_oss - dynamic_tau = pfem_nonewtonian_var.dynamic_tau - solver.echo_level = 2 - model_part.ProcessInfo.SetValue(OSS_SWITCH, oss_swith); - model_part.ProcessInfo.SetValue(DYNAMIC_TAU, dynamic_tau); - solver.Initialize(output_Dt) - - -time = 0.0 -for step in range(0, nsteps): - print("line49") - - new_Dt = solver.EstimateDeltaTime(min_dt, max_dt) - - time = time + new_Dt * safety_factor - - model_part.CloneTimeStep(time) - - print(time) - - # solving the fluid problem - if(step > 3): - solver.Solve(time, gid_io) diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.rdr b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.rdr deleted file mode 100644 index ea11fa082101..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.rdr and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.vv b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.vv deleted file mode 100644 index 3e19e69c2a89..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.vv +++ /dev/null @@ -1,19 +0,0 @@ -BeginZE /home/antonia/kratos/applications/PFEMapplication/test_exemples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.vv - x -0.294929 1.37769 - y 1.14718 -0.324574 - z -4.96236 4.96236 - e 1.65412 - v 0 0 0 - r 1 - m 1 0 0 0 0 1 0 0 0 0 1 0 0 0 0 1 - c 1.25 1 0 - pd 0 - pno 0 - pfo 0 - pf 4 - pv 0 - NowUse 1 - DrawingType 0 - LightVector 90 90 150 0 -EndZE /home/antonia/kratos/applications/PFEMapplication/test_exemples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500.vv - diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500_aux.unix.bat b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500_aux.unix.bat deleted file mode 100755 index 645abbd6e304..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500_aux.unix.bat +++ /dev/null @@ -1,25 +0,0 @@ -#!/bin/bash -i - -write_python_file="Use_Default" -file_location="script.py" -problemtype_name=pfem_nonewtonian - -mv $2/$1-3.dat $2/${problemtype_name}_var.py - -echo "problem_name=\"${1}\"" >> ${problemtype_name}_var.py -echo "problem_path=\"${2}\"" >> ${problemtype_name}_var.py -echo "kratos_path=\"${KRATOS_PATH}\"" >> ${problemtype_name}_var.py - -if [ $write_python_file = "Use_Default" ] -then - cp $3/script.py $2/ -# cp $3/run_example_trilinos.py $2/ -elif [ $write_python_file = "Copy_From" ] -then - cp $file_location $2/script.py -fi - -if [ -f script.py ] -then - python $2/script.py >& $2/$1.info -fi diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500_out.mdpa b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_Y1500_out.mdpa deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_benchmark.py b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_benchmark.py deleted file mode 100644 index 01f9da8b206c..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_benchmark.py +++ /dev/null @@ -1,22 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import sys -kratos_benchmarking_path = '../../../../benchmarking' -sys.path.append(kratos_benchmarking_path) -import benchmarking - -Text = " " - -# -print("verifying dam2dNonNewt.py...") -successful,Msg = benchmarking.RunBenchmark("dam2dNonNewt.py", "dam2dNonNewt_ref.txt") - -if(successful==True): - Text += "OK\n" - print("dam2dNonNewt example SUCCESFUL") -else: - Text += "FAILED\n" - Text += Msg - Text += "\n\n" - print("dam2dNonNewt example FAILED") - -print(Text) diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_build_reference.py b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_build_reference.py deleted file mode 100644 index eb06116d5b0c..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_build_reference.py +++ /dev/null @@ -1,8 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import sys -kratos_benchmarking_path = '../../../../benchmarking' -sys.path.append(kratos_benchmarking_path) -import benchmarking - -print("Building reference data for dam2dNonNewt.py...") -benchmarking.BuildReferenceData("dam2dNonNewt.py", "dam2dNonNewt_ref.txt") diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_ref.txt b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_ref.txt deleted file mode 100644 index 3596b7ebe98e..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/dam2dNonNewt_ref.txt +++ /dev/null @@ -1,438 +0,0 @@ -KRATOS_BENCHMARK | Float | Time | 0.05 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2279.05931133 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.023471492305 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.06 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2418.75462404 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.0629619467385 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.07 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2438.65356544 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.101744838508 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.08 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2470.28333501 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.140206410961 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.09 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2491.04679451 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.178122178779 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.1 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2705.84482124 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.213066369259 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.11 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2599.90495742 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.247568055322 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.12 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2774.18349824 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.281168647451 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.13 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2790.94149096 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.3132899026 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.139271934142 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2936.41557253 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.341486649765 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.147577459507 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2987.333355 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.365365118802 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.155150799109 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3335.17743971 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.383545163563 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.16218995843 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3123.31792147 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.400221533387 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.168768781703 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3253.23994366 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.416383509106 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.174937446499 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3372.99596025 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.429689906183 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.180820706625 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3524.10971776 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.440800478762 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.186433963033 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3423.35748636 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.451764123904 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.191804955578 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3574.85249249 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.461852200838 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.196957595727 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3457.93872091 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.471652093036 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.201911942818 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3668.37201555 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.480340951177 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.206686420174 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3631.96364333 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.488042513065 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.211296502277 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3996.24320025 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.4948400691 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.215755962253 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 13072.9235902 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.452062796974 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.220389854845 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | -7607.53096775 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.483557361701 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.224762856999 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 12725.4090289 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.486561632076 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.22906471266 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | -2574.65032991 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.49041436733 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.233213592884 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 8247.28138296 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.49716861288 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.237267644264 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 1661.74993349 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.497459712044 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.241232385188 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5840.37272283 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.499114584342 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.245109164436 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2914.43851071 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.500889664192 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.248893443472 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4912.21498 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.50230456307 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.252589634053 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3617.68418178 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.503855082958 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.256201116303 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4641.08336703 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.50493919615 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.259734923417 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3998.39413983 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.505910264401 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.263194420462 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4059.97380405 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.508604485346 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.266610547944 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4885.94986325 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.507247943555 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.269970506414 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3767.13930768 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.50791441468 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.273273351533 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4799.31585603 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.508157405542 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.276524423689 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4124.3221527 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.507923832803 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.279725028746 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4529.49356615 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.507851042254 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.282878091867 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4595.83224069 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.506421773953 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.285992086565 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4823.86244617 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.503748046667 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.289089381093 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4057.72616705 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.503185142863 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.292162898358 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4443.36661726 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.502983761805 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.295200103187 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4036.68224466 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.50311768267 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.298228619764 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4972.15613804 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.500870583194 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.301231985703 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4097.40731302 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.49923241064 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.304204983335 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5192.22576148 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.49567335844 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.307151757653 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3919.36737929 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.493947863702 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.310068408223 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5044.94634273 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.491525407272 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.312955476204 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4220.78687714 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.488687811804 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.315814007939 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4640.71444844 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.486472694632 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.318644364943 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4110.5958344 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.485572543583 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.321442444245 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4464.56964387 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.48496010624 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.324210015937 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4117.80717564 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.485332170545 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.326974171593 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4853.29581153 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.483605445994 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.329722026911 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4983.77530202 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.478391898761 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.33245139995 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4275.31808004 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.475682820195 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.335162806534 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4179.29171255 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.475702188259 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.33785676978 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4485.61389241 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.474532692317 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.340534375928 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5141.20686694 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.469723048701 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.34319787096 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4089.97519623 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.467166353786 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.34584588599 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4416.31275389 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.466515694709 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.348479045104 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4416.77272368 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.465425214597 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.351102288425 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4041.76495592 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.465247612232 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.35372328898 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4612.79681892 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.464216356372 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.35633306896 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4535.41419972 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.461791491848 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.358948866479 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4247.88398362 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.459663642665 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.361609813765 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4443.17261449 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.457191101306 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.364301626213 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3924.00511268 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.456305100762 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.367004343552 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4835.51685181 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.453471240579 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.369622647564 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3379.80443957 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.453586259344 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.372207029464 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 5190.56293174 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.450933317361 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.374781088482 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3540.92848496 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.449595712277 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.377344329108 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4742.91278191 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.447830269118 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.3799041332 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4057.13460044 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.445325711462 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.382456747531 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4208.22832168 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.44382738686 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.385000347837 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4109.01179192 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.442405766962 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.387534166794 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4648.64949942 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.439202389373 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.390059690246 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3782.6137237 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.437581690344 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.392578336675 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4881.04922301 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.434165459798 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.395091059252 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4058.51758147 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.430422244224 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.397597787289 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4055.86733979 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.42888306272 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.40009870152 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3979.37155671 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.427764880861 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.40259366753 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4044.17309295 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.426546366994 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.405084031313 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4176.3171655 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.424898368831 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.407570290189 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4148.78551321 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.422735133172 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.410053004717 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4157.0374578 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.42018132401 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.412531588883 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3883.73507089 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.418486850531 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.415006239823 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3829.87452363 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.418024878061 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.417476020577 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4018.08022073 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.417041277202 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.419941623976 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3856.20973065 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.41589654201 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.422403594965 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4135.43174588 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.413734710443 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.424859796611 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3725.18050843 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.412357714622 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.427308936993 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4142.0777303 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.408767068231 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.42975812782 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4149.0774661 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.40402001611 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.432208668044 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3778.39674431 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.401410955525 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.434672021743 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4003.70060981 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.399515057739 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.437120007559 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4445.12239861 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.394016803635 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.439558524356 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3729.35350547 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.389443885784 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.441993651052 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3789.72654292 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.387696634705 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.444425001759 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3877.7700137 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.385854797482 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.446845474392 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3677.07993224 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.384557332238 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.449262002469 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3869.35262311 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.383088403901 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.451677870894 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3652.66726372 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.381993213112 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.454091308818 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4208.05983949 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.379222940767 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.456818473153 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2778.17509938 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.380016511735 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.459985481569 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4874.3954185 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.378198980651 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.463178740132 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2564.6639978 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.381406443525 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.46642428501 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4895.98102778 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.379842374023 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.469684218168 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2810.36363861 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.380211054752 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.472947073019 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4644.89769424 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.378278053263 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.47622017825 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2929.68240694 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.378501596129 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.479509503275 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4250.66083077 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.377700761854 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.482803973906 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3353.16149594 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.376545953918 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.486086416991 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 4423.74115318 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.372446131365 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.489366383362 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3262.86317681 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.369962428444 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.492641590891 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3606.88066801 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.370391469473 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.49591025364 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3585.44137226 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.368661746566 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.499172882939 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3502.43657208 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.366375429903 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.502429450328 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3540.99770793 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.364232708246 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.505681652784 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3484.25587402 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.362132639818 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.508895382426 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3851.10819491 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.358204533462 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.512094503521 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3248.41159955 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.355917275648 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.515299321633 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3450.2801996 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.355122086526 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.518504773228 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3763.20479802 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.35167997545 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.521722521532 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3130.25158547 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.350431032675 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.524944434668 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3797.82990588 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.348349980102 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.52820363174 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3010.44920659 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.347579696431 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.531529222412 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3859.86863434 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.345086732558 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.53487882298 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3216.53200925 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.342527543997 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.538218740152 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3286.9672516 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.342456749349 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.54157080936 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3462.19924012 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.341791749171 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.544937817573 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3170.40163035 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.341773880736 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.548310013962 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3972.64314625 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.337256884624 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.551673985758 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3008.46546145 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.335367715075 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.555035750413 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3435.08316525 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.335867206311 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.558143596748 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3331.39604283 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.335026767116 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.56117432214 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3890.4295982 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.331027253687 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.564567141473 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 2772.4181724 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.330078541956 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.567955139499 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3457.74657853 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.329918170285 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.570798466254 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3040.70235022 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.329402614111 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.573287076233 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3329.72985295 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.328910164518 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.575540106035 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3087.180504 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.328756143924 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.578884116552 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3174.43666778 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.328328010728 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Time | 0.582218673686 | 0.0001 | 0.0001 -KRATOS_BENCHMARK | Float | Node 1 pressure | 3156.96383194 | 0.01 | 1e-05 -KRATOS_BENCHMARK | Float | Node 2 velocity_y | -0.327586877346 | 0.01 | 1e-05 diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/err.log b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/err.log deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/out.out b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/out.out deleted file mode 100644 index 5de5a4a0795c..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/out.out +++ /dev/null @@ -1,38708 +0,0 @@ -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: False -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosMKLSolversApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: True -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: True -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -importing KratosIncompressibleFluidApplication ... -KratosIncompressibleFluidApplication lib loaded -KratosIncompressibleFluidApplication application created -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing KratosIncompressibleFluidApplication... -Initializing KratosIncompressibleFluidApplication...Register completed -Initializing KratosIncompressibleFluidApplication...variables succesfully registered -Initializing KratosIncompressibleFluidApplication...elements succesfully registered -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosIncompressibleFluidApplication Succesfully imported -importing KratosPFEMApplication ... -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing Kratos PFEMApplication... -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosPFEMApplication Succesfully imported -importing KratosMeshingApplication ... -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing Kratos MeshingApplication... -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosMeshingApplication sucessfully imported -variables for the dynamic structural solution added correctly -dam2dNonNewt_Y1500 opened for io -dam2dNonNewt_Y1500.node opened for io -dam2dNonNewt_Y1500.prop opened for io -dam2dNonNewt_Y1500.elem opened for io -dam2dNonNewt_Y1500.cond opened for io -dam2dNonNewt_Y1500.init opened for io -initializing result files - Reading Nodes : 124 nodes read - Reading Elements : 138 NoNewtonianASGS2D read -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DISPLACEMENT_X -rVariable : DISPLACEMENT_X component of DISPLACEMENT variable #94 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DISPLACEMENT_Y -rVariable : DISPLACEMENT_Y component of DISPLACEMENT variable #95 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : DISPLACEMENT_Z -rVariable : DISPLACEMENT_Z component of DISPLACEMENT variable #96 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VELOCITY_X -rVariable : VELOCITY_X component of VELOCITY variable #292 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VELOCITY_Y -rVariable : VELOCITY_Y component of VELOCITY variable #293 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : VELOCITY_Z -rVariable : VELOCITY_Z component of VELOCITY variable #294 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : IS_BOUNDARY -rVariable : IS_BOUNDARY variable #148 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : IS_FREE_SURFACE -rVariable : IS_FREE_SURFACE variable #157 -kratos_double_variables : Kratos components - AIR_ENTRY_VALUE - AIR_PRESSURE - AIR_PRESSURE_ACCELERATION - AIR_PRESSURE_DT - AIR_PRESSURE_EINS - AIR_PRESSURE_EINS_ACCELERATION - AIR_PRESSURE_EINS_DT - AIR_PRESSURE_NULL - AIR_PRESSURE_NULL_ACCELERATION - AIR_PRESSURE_NULL_DT - AIR_SOUND_VELOCITY - ARRHENIUS - ARRHENIUSAUX - ARRHENIUSAUX_ - AUX_INDEX - BULK_AIR - BULK_MODULUS - CONCENTRATION - CONCENTRATION_DT - CONCENTRATION_DT2 - CONCENTRATION_EINS - CONCENTRATION_EINS_DT - CONCENTRATION_EINS_DT2 - CONCENTRATION_NULL - CONCENTRATION_NULL_DT - CONCENTRATION_NULL_DT2 - CONTACT_STICK - CRACK_OPENING - CRACK_TRANSLATION - DELTA_TIME - DENSITY - DENSITY_AIR - DENSITY_WATER - DIAMETER - DISTANCE - DIVPROJ - DP_ALPHA1 - DP_EPSILON - DP_K - DYNAMIC_TAU - ELECTRIC_POTENTIAL - ELECTRIC_POTENTIAL_DT - ELECTRIC_POTENTIAL_DT2 - ELECTRIC_POTENTIAL_EINS - ELECTRIC_POTENTIAL_EINS_DT - ELECTRIC_POTENTIAL_EINS_DT2 - ELECTRIC_POTENTIAL_NULL - ELECTRIC_POTENTIAL_NULL_DT - ELECTRIC_POTENTIAL_NULL_DT2 - END_TIME - ERASE_FLAG - ERROR_RATIO - EXTERNAL_PRESSURE - FIRST_SATURATION_PARAM - FLAG_VARIABLE - FRICTION_COEFFICIENT - FUEL - INITIAL_PENALTY - IS_BOUNDARY - IS_BURN - IS_DIVIDED - IS_DRIPPING - IS_EROSIONABLE - IS_FLUID - IS_FREE_SURFACE - IS_INTERFACE - IS_LAGRANGIAN_INLET - IS_PERMANENT - IS_POROUS - IS_STRUCTURE - IS_VISITED - IS_WALL - IS_WATER - IS_WATER_ELEMENT - LAGRANGE_AIR_PRESSURE - LAGRANGE_CONCENTRATION - LAGRANGE_ELECTRIC_POTENTIAL - LAGRANGE_TEMPERATURE - LAGRANGE_WATER_PRESSURE - LAMBDA - M - MACH_NUMBER - MATERIAL_VARIABLE - MIU - MU - NEGATIVE_FACE_PRESSURE - NODAL_AREA - NODAL_H - NODAL_MASS - NODAL_MAUX - NODAL_PAUX - NODAL_SWITCH - NORMAL_CONTACT_STRESS - PARTITION_INDEX - PERMEABILITY_AIR - PERMEABILITY_INV - PERMEABILITY_WATER - POISSON_RATIO - POROSITY - POSITIVE_FACE_PRESSURE - PRESSURE - PRESSUREAUX - PRESSURE_COEFFICIENT - PRESSURE_OLD_IT - REACTION_AIR_PRESSURE - REACTION_WATER_PRESSURE - SATURATION - SECOND_SATURATION_PARAM - SOUND_VELOCITY - START_TIME - SUCTION - TANGENTIAL_CONTACT_STRESS - TAU - TC - TEMPERATURE - THAWONE - THAWTWO - THICKNESS - TIME - VISCOSITY - VISCOSITY_AIR - VISCOSITY_WATER - WATER_PRESSURE - WATER_PRESSURE_ACCELERATION - WATER_PRESSURE_DT - WATER_PRESSURE_EINS - WATER_PRESSURE_EINS_ACCELERATION - WATER_PRESSURE_EINS_DT - WATER_PRESSURE_NULL - WATER_PRESSURE_NULL_ACCELERATION - WATER_PRESSURE_NULL_DT - WATER_SOUND_VELOCITY - Y1 - Y2 - YF - YI - YIELD_STRESS - YO - YOUNG_MODULUS - YP - -variable_name : IS_STRUCTURE -rVariable : IS_STRUCTURE variable #164 -lines read : 777 -writing a 2D mesh -FluidPart model part - Buffer Size : 1 - Current solution step index : 0 - - Mesh 0 : - Number of Nodes : 124 - Number of Properties : 1 - Number of Elements : 138 - Number of Conditions : 32 - -Pointer vector set (size = 1) : -Properties - - -dofs for the monolithic solver added correctly -using the velocity Bossak Time Integration Scheme -Node #80 : (0.41498 , 0.50122 , 0) - Dofs : - Free PRESSURE degree of freedom - Free VELOCITY_X degree of freedom - Free VELOCITY_Y degree of freedom - Free VELOCITY_Z degree of freedom - Free AIR_PRESSURE degree of freedom - -line49 -Estimating delta time -0.01 -line49 -Estimating delta time -0.02 -line49 -Estimating delta time -0.03 -line49 -Estimating delta time -0.04 -line49 -Estimating delta time -0.05 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.05 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00196409 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1; expected ratio = 1e-07obtained abs = 3.81178e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1; expected ratio = 0.0001obtained abs = 305.807; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000956059 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.639310e+05 Mflops = 10.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.404352; expected ratio = 1e-07obtained abs = 2.55815e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0795107; expected ratio = 0.0001obtained abs = 23.6575; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000956059 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.300402; expected ratio = 1e-07obtained abs = 2.70847e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0397576; expected ratio = 0.0001obtained abs = 11.5558; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000934124 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.242001; expected ratio = 1e-07obtained abs = 2.87311e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0290922; expected ratio = 0.0001obtained abs = 8.3258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000928879 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.197649; expected ratio = 1e-07obtained abs = 2.9203e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0229992; expected ratio = 0.0001obtained abs = 6.49925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000977039 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.163805; expected ratio = 1e-07obtained abs = 2.89091e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0189188; expected ratio = 0.0001obtained abs = 5.28302; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000972033 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.135238; expected ratio = 1e-07obtained abs = 2.75738e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0162025; expected ratio = 0.0001obtained abs = 4.47567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000976086 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.109898; expected ratio = 1e-07obtained abs = 2.51538e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0138524; expected ratio = 0.0001obtained abs = 3.79007; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000977993 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0875234; expected ratio = 1e-07obtained abs = 2.19384e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01159; expected ratio = 0.0001obtained abs = 3.14542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000945091 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.635410e+05 Mflops = 10.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0683795; expected ratio = 1e-07obtained abs = 1.83856e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00879168; expected ratio = 0.0001obtained abs = 2.37305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000967979 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.635410e+05 Mflops = 21.81 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0524055; expected ratio = 1e-07obtained abs = 1.48604e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0073318; expected ratio = 0.0001obtained abs = 1.96884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000952005 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0395864; expected ratio = 1e-07obtained abs = 1.1681e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00570391; expected ratio = 0.0001obtained abs = 1.52542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000942945 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0295797; expected ratio = 1e-07obtained abs = 8.98912e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00432459; expected ratio = 0.0001obtained abs = 1.15287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000952005 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0219359; expected ratio = 1e-07obtained abs = 6.81197e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00323265; expected ratio = 0.0001obtained abs = 0.859697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000967026 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.651810e+05 Mflops = 21.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0161923; expected ratio = 1e-07obtained abs = 5.10844e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00239687; expected ratio = 0.0001obtained abs = 0.636265; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000946999 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0119275; expected ratio = 1e-07obtained abs = 3.8065e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00177142; expected ratio = 0.0001obtained abs = 0.469591; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000957966 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00878646; expected ratio = 1e-07obtained abs = 2.82763e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00131052; expected ratio = 0.0001obtained abs = 0.347054; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000972033 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00648475; expected ratio = 1e-07obtained abs = 2.09961e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000974198; expected ratio = 0.0001obtained abs = 0.257789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000951052 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.651810e+05 Mflops = 21.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00480241; expected ratio = 1e-07obtained abs = 1.56179e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000730001; expected ratio = 0.0001obtained abs = 0.193058; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000946999 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.651810e+05 Mflops = 21.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00357338; expected ratio = 1e-07obtained abs = 1.16583e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000552802; expected ratio = 0.0001obtained abs = 0.146132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000967979 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00267435; expected ratio = 1e-07obtained abs = 8.74562e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000423752; expected ratio = 0.0001obtained abs = 0.111981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962973 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00201484; expected ratio = 1e-07obtained abs = 6.60016e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000329044; expected ratio = 0.0001obtained abs = 0.0869315; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000972986 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.651810e+05 Mflops = 21.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00152898; expected ratio = 1e-07obtained abs = 5.01486e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000258759; expected ratio = 0.0001obtained abs = 0.0683494; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000961065 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.651810e+05 Mflops = 10.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00116908; expected ratio = 1e-07obtained abs = 3.83797e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000205874; expected ratio = 0.0001obtained abs = 0.0543723; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00095892 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000900751; expected ratio = 1e-07obtained abs = 2.95907e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000165476; expected ratio = 0.0001obtained abs = 0.0436978; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962019 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000699219; expected ratio = 1e-07obtained abs = 2.29816e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134143; expected ratio = 0.0001obtained abs = 0.0354205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000972986 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00054666; expected ratio = 1e-07obtained abs = 1.79741e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000109497; expected ratio = 0.0001obtained abs = 0.0289108; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000935078 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.651810e+05 Mflops = 21.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000430233; expected ratio = 1e-07obtained abs = 1.41499e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.98716e-05; expected ratio = 0.0001obtained abs = 0.0237277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000969172 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000340658; expected ratio = 1e-07obtained abs = 1.12062e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.40841e-05; expected ratio = 0.0001obtained abs = 0.0195587; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000961065 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000271203; expected ratio = 1e-07obtained abs = 8.92283e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.12812e-05; expected ratio = 0.0001obtained abs = 0.0161781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.06 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.06 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000975132 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.651810e+05 Mflops = 21.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.348827; expected ratio = 1e-07obtained abs = 0.000175962; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.163619; expected ratio = 0.0001obtained abs = 48.4656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000969887 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.238711; expected ratio = 1e-07obtained abs = 0.000158156; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0745011; expected ratio = 0.0001obtained abs = 21.0493; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000975132 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.143533; expected ratio = 1e-07obtained abs = 0.000111007; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0507273; expected ratio = 0.0001obtained abs = 13.8817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000971079 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.659820e+05 Mflops = 10.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0769245; expected ratio = 1e-07obtained abs = 6.44248e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0295949; expected ratio = 0.0001obtained abs = 7.94483; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00099206 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.659820e+05 Mflops = 21.96 -Solve time = 0.02 -Solve flops = 2.458000e+04 Mflops = 1.47 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0384479; expected ratio = 1e-07obtained abs = 3.34732e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0148839; expected ratio = 0.0001obtained abs = 3.95931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962973 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.018634; expected ratio = 1e-07obtained abs = 1.65239e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00732849; expected ratio = 0.0001obtained abs = 1.93961; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000949144 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00902666; expected ratio = 1e-07obtained abs = 8.07401e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00348635; expected ratio = 0.0001obtained abs = 0.920412; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00096488 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00449076; expected ratio = 1e-07obtained abs = 4.03321e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00167349; expected ratio = 0.0001obtained abs = 0.441279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000972986 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.659820e+05 Mflops = 10.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00236888; expected ratio = 1e-07obtained abs = 2.13165e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000844484; expected ratio = 0.0001obtained abs = 0.222557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000969887 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00136857; expected ratio = 1e-07obtained abs = 1.23266e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000469991; expected ratio = 0.0001obtained abs = 0.123832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000972033 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000876978; expected ratio = 1e-07obtained abs = 7.90249e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000297886; expected ratio = 0.0001obtained abs = 0.0784792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000965834 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0006126; expected ratio = 1e-07obtained abs = 5.52142e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000212142; expected ratio = 0.0001obtained abs = 0.0558886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000967979 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000452966; expected ratio = 1e-07obtained abs = 4.08311e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000162949; expected ratio = 0.0001obtained abs = 0.0429291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000959873 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000346582; expected ratio = 1e-07obtained abs = 3.12434e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000130489; expected ratio = 0.0001obtained abs = 0.0343783; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000976086 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000270951; expected ratio = 1e-07obtained abs = 2.44263e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000106914; expected ratio = 0.0001obtained abs = 0.0281679; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962019 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000215104; expected ratio = 1e-07obtained abs = 1.9392e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.88238e-05; expected ratio = 0.0001obtained abs = 0.0234025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000957966 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.659820e+05 Mflops = 21.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000172923; expected ratio = 1e-07obtained abs = 1.55896e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.45243e-05; expected ratio = 0.0001obtained abs = 0.0196354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962973 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.659820e+05 Mflops = 10.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000140595; expected ratio = 1e-07obtained abs = 1.26751e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.30345e-05; expected ratio = 0.0001obtained abs = 0.0166084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000953913 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000115548; expected ratio = 1e-07obtained abs = 1.04171e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.37123e-05; expected ratio = 0.0001obtained abs = 0.0141524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962973 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.59669e-05; expected ratio = 1e-07obtained abs = 8.65183e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.60981e-05; expected ratio = 0.0001obtained abs = 0.0121464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.07 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.07 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000957966 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.269757; expected ratio = 1e-07obtained abs = 0.000332733; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.116708; expected ratio = 0.0001obtained abs = 33.3114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000990152 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.117211; expected ratio = 1e-07obtained abs = 0.000163742; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0812461; expected ratio = 0.0001obtained abs = 22.0488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000948906 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0430574; expected ratio = 1e-07obtained abs = 6.28282e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0309803; expected ratio = 0.0001obtained abs = 8.24009; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000939846 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.672700e+05 Mflops = 11.02 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0148675; expected ratio = 1e-07obtained abs = 2.2012e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0105008; expected ratio = 0.0001obtained abs = 2.77252; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000951767 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.700080e+05 Mflops = 11.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00519215; expected ratio = 1e-07obtained abs = 7.72445e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00351643; expected ratio = 0.0001obtained abs = 0.926042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000918865 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00197126; expected ratio = 1e-07obtained abs = 2.93745e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00124771; expected ratio = 0.0001obtained abs = 0.328289; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000969887 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000900322; expected ratio = 1e-07obtained abs = 1.34235e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000527254; expected ratio = 0.0001obtained abs = 0.138688; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000968933 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.715740e+05 Mflops = 22.29 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000516491; expected ratio = 1e-07obtained abs = 7.70223e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000292964; expected ratio = 0.0001obtained abs = 0.0770549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000977039 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.715740e+05 Mflops = 11.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000346182; expected ratio = 1e-07obtained abs = 5.16285e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000200802; expected ratio = 0.0001obtained abs = 0.052815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000956059 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000251399; expected ratio = 1e-07obtained abs = 3.74939e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000152333; expected ratio = 0.0001obtained abs = 0.0400678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000950098 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191247; expected ratio = 1e-07obtained abs = 2.8523e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000121171; expected ratio = 0.0001obtained abs = 0.0318724; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000957966 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000150368; expected ratio = 1e-07obtained abs = 2.24264e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.88365e-05; expected ratio = 0.0001obtained abs = 0.0259984; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000969887 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000121293; expected ratio = 1e-07obtained abs = 1.80901e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.18187e-05; expected ratio = 0.0001obtained abs = 0.0215226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000976086 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.98296e-05; expected ratio = 1e-07obtained abs = 1.4889e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.83847e-05; expected ratio = 0.0001obtained abs = 0.0179892; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000960827 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.3468e-05; expected ratio = 1e-07obtained abs = 1.24487e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.756e-05; expected ratio = 0.0001obtained abs = 0.015142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000937939 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.06506e-05; expected ratio = 1e-07obtained abs = 1.05371e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.87299e-05; expected ratio = 0.0001obtained abs = 0.0128194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000970125 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.715740e+05 Mflops = 11.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.03793e-05; expected ratio = 1e-07obtained abs = 9.0052e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.14679e-05; expected ratio = 0.0001obtained abs = 0.0109091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.08 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.08 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000980139 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.216048; expected ratio = 1e-07obtained abs = 0.000410818; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0883545; expected ratio = 0.0001obtained abs = 24.6835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000949144 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0653026; expected ratio = 1e-07obtained abs = 0.000132809; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0707154; expected ratio = 0.0001obtained abs = 18.9133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000972986 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.685800e+05 Mflops = 11.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0171861; expected ratio = 1e-07obtained abs = 3.55475e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.018153; expected ratio = 0.0001obtained abs = 4.79509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000970125 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0045463; expected ratio = 1e-07obtained abs = 9.44316e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0044773; expected ratio = 0.0001obtained abs = 1.17868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000961065 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00134667; expected ratio = 1e-07obtained abs = 2.8002e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118577; expected ratio = 0.0001obtained abs = 0.311878; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000977039 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000515756; expected ratio = 1e-07obtained abs = 1.07274e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000399175; expected ratio = 0.0001obtained abs = 0.104965; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000976086 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000263683; expected ratio = 1e-07obtained abs = 5.4849e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000194782; expected ratio = 0.0001obtained abs = 0.051216; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000949144 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000159727; expected ratio = 1e-07obtained abs = 3.32259e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000122177; expected ratio = 0.0001obtained abs = 0.0321253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962019 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000105982; expected ratio = 1e-07obtained abs = 2.20462e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.65047e-05; expected ratio = 0.0001obtained abs = 0.0227459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000975132 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.52236e-05; expected ratio = 1e-07obtained abs = 1.5648e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.54107e-05; expected ratio = 0.0001obtained abs = 0.0171997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000966072 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.684660e+05 Mflops = 22.11 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.6541e-05; expected ratio = 1e-07obtained abs = 1.17617e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.13661e-05; expected ratio = 0.0001obtained abs = 0.0135068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00118208 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.684660e+05 Mflops = 22.11 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.45304e-05; expected ratio = 1e-07obtained abs = 9.26322e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.12295e-05; expected ratio = 0.0001obtained abs = 0.0108415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.09 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.09 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000951052 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.662620e+05 Mflops = 21.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.17974; expected ratio = 1e-07obtained abs = 0.000455677; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0711562; expected ratio = 0.0001obtained abs = 19.6403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000977993 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.662620e+05 Mflops = 10.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0401801; expected ratio = 1e-07obtained abs = 0.000106087; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0608117; expected ratio = 0.0001obtained abs = 16.1635; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962019 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00820655; expected ratio = 1e-07obtained abs = 2.1838e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0116221; expected ratio = 0.0001obtained abs = 3.06353; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000970125 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00181554; expected ratio = 1e-07obtained abs = 4.83871e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00228645; expected ratio = 0.0001obtained abs = 0.601633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000964165 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000526294; expected ratio = 1e-07obtained abs = 1.4031e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000550942; expected ratio = 0.0001obtained abs = 0.144916; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00090909 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.661580e+05 Mflops = 21.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000231744; expected ratio = 1e-07obtained abs = 6.17876e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000219459; expected ratio = 0.0001obtained abs = 0.0577213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000988007 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133704; expected ratio = 1e-07obtained abs = 3.56489e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00013643; expected ratio = 0.0001obtained abs = 0.0358835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000935078 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.79969e-05; expected ratio = 1e-07obtained abs = 2.34623e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.95778e-05; expected ratio = 0.0001obtained abs = 0.0261912; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962019 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.30633e-05; expected ratio = 1e-07obtained abs = 1.68144e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.64507e-05; expected ratio = 0.0001obtained abs = 0.0201086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000937939 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.661580e+05 Mflops = 21.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.80037e-05; expected ratio = 1e-07obtained abs = 1.27991e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.98801e-05; expected ratio = 0.0001obtained abs = 0.0157503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962973 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.661580e+05 Mflops = 21.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.8051e-05; expected ratio = 1e-07obtained abs = 1.01454e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.7391e-05; expected ratio = 0.0001obtained abs = 0.0124655; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000966072 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.09674e-05; expected ratio = 1e-07obtained abs = 8.25676e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.77727e-05; expected ratio = 0.0001obtained abs = 0.00993562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.1 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.1 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.0009799 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.661580e+05 Mflops = 10.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.153693; expected ratio = 1e-07obtained abs = 0.000484094; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0593548; expected ratio = 0.0001obtained abs = 16.2537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000974894 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0263701; expected ratio = 1e-07obtained abs = 8.52699e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0528325; expected ratio = 0.0001obtained abs = 13.9976; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000946045 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00438578; expected ratio = 1e-07obtained abs = 1.42392e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00787425; expected ratio = 0.0001obtained abs = 2.07405; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000928164 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000868003; expected ratio = 1e-07obtained abs = 2.81996e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00131321; expected ratio = 0.0001obtained abs = 0.345543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00088501 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647700e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000273281; expected ratio = 1e-07obtained abs = 8.87933e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000319634; expected ratio = 0.0001obtained abs = 0.0840913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00095892 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000139744; expected ratio = 1e-07obtained abs = 4.5406e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000157173; expected ratio = 0.0001obtained abs = 0.0413495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000932932 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.95038e-05; expected ratio = 1e-07obtained abs = 2.9082e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000110873; expected ratio = 0.0001obtained abs = 0.0291692; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000962019 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.38341e-05; expected ratio = 1e-07obtained abs = 2.07413e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.46205e-05; expected ratio = 0.0001obtained abs = 0.0222628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000974178 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647700e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.83563e-05; expected ratio = 1e-07obtained abs = 1.57122e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.5782e-05; expected ratio = 0.0001obtained abs = 0.0173068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000967026 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647700e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.7898e-05; expected ratio = 1e-07obtained abs = 1.2314e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.14986e-05; expected ratio = 0.0001obtained abs = 0.013549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000936985 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.0292e-05; expected ratio = 1e-07obtained abs = 9.84265e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.0503e-05; expected ratio = 0.0001obtained abs = 0.0106562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.11 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.11 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000971079 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.644180e+05 Mflops = 10.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.134056; expected ratio = 1e-07obtained abs = 0.000502924; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0510319; expected ratio = 0.0001obtained abs = 13.8998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000972986 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0180809; expected ratio = 1e-07obtained abs = 6.90472e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0464658; expected ratio = 0.0001obtained abs = 12.2917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000966072 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00253839; expected ratio = 1e-07obtained abs = 9.71529e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00550957; expected ratio = 0.0001obtained abs = 1.45269; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000950813 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000476965; expected ratio = 1e-07obtained abs = 1.82606e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000797341; expected ratio = 0.0001obtained abs = 0.210141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00088501 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.644180e+05 Mflops = 21.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000174087; expected ratio = 1e-07obtained abs = 6.66521e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000230542; expected ratio = 0.0001obtained abs = 0.0607586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000974178 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000102; expected ratio = 1e-07obtained abs = 3.90529e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000140062; expected ratio = 0.0001obtained abs = 0.036914; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000937939 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.06059e-05; expected ratio = 1e-07obtained abs = 2.70329e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103256; expected ratio = 0.0001obtained abs = 0.0272143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00107503 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.23935e-05; expected ratio = 1e-07obtained abs = 2.00599e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.88827e-05; expected ratio = 0.0001obtained abs = 0.0207908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000950813 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.644180e+05 Mflops = 21.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.02197e-05; expected ratio = 1e-07obtained abs = 1.53989e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.09792e-05; expected ratio = 0.0001obtained abs = 0.0160722; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000961065 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.644180e+05 Mflops = 21.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.14431e-05; expected ratio = 1e-07obtained abs = 1.20386e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.7467e-05; expected ratio = 0.0001obtained abs = 0.0125109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000965118 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.48586e-05; expected ratio = 1e-07obtained abs = 9.51761e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.71422e-05; expected ratio = 0.0001obtained abs = 0.00978968; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.12 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 139 - - Mesh vertices: 124 - Mesh triangles: 139 - Mesh edges: 225 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.12 -matrix_partition : [9](0,28,56,84,112,140,168,196,225) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000941038 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.622140e+05 Mflops = 10.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.118696; expected ratio = 1e-07obtained abs = 0.000515585; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.044575; expected ratio = 0.0001obtained abs = 12.107; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00096488 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0127835; expected ratio = 1e-07obtained abs = 5.62172e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0412497; expected ratio = 0.0001obtained abs = 10.9167; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000938892 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00155765; expected ratio = 1e-07obtained abs = 6.85893e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00404625; expected ratio = 0.0001obtained abs = 1.06748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00104594 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000298449; expected ratio = 1e-07obtained abs = 1.31438e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000551429; expected ratio = 0.0001obtained abs = 0.145422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000936031 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.625660e+05 Mflops = 21.75 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000130887; expected ratio = 1e-07obtained abs = 5.76443e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000170784; expected ratio = 0.0001obtained abs = 0.0450375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000952959 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.46296e-05; expected ratio = 1e-07obtained abs = 3.72721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000117026; expected ratio = 0.0001obtained abs = 0.0308614; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000958204 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.09044e-05; expected ratio = 1e-07obtained abs = 2.68232e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.01293e-05; expected ratio = 0.0001obtained abs = 0.0237686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00098896 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.56198e-05; expected ratio = 1e-07obtained abs = 2.00916e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.99534e-05; expected ratio = 0.0001obtained abs = 0.0184481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000965118 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.48165e-05; expected ratio = 1e-07obtained abs = 1.53337e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.44696e-05; expected ratio = 0.0001obtained abs = 0.0143648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.000967979 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.625660e+05 Mflops = 21.75 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.68544e-05; expected ratio = 1e-07obtained abs = 1.1827e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.2567e-05; expected ratio = 0.0001obtained abs = 0.0112259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,139) -time: 0.00097394 -"finished parallel building" : finished parallel building -matrix size in solver: 225 -RHS size in solver: 225 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.08632e-05; expected ratio = 1e-07obtained abs = 9.18843e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.33827e-05; expected ratio = 0.0001obtained abs = 0.00880383; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.13 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.13 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000953913 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.631520e+05 Mflops = 10.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.102602; expected ratio = 1e-07obtained abs = 0.00050258; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.104682; expected ratio = 0.0001obtained abs = 28.4674; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000939846 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00876574; expected ratio = 1e-07obtained abs = 4.32958e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0345866; expected ratio = 0.0001obtained abs = 9.2142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000983953 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00106289; expected ratio = 1e-07obtained abs = 5.25396e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00296134; expected ratio = 0.0001obtained abs = 0.787259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000967979 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000270733; expected ratio = 1e-07obtained abs = 1.33839e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000465436; expected ratio = 0.0001obtained abs = 0.123704; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000904083 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000127323; expected ratio = 1e-07obtained abs = 6.29441e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000189618; expected ratio = 0.0001obtained abs = 0.0503951; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000963926 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.55339e-05; expected ratio = 1e-07obtained abs = 3.73414e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126566; expected ratio = 0.0001obtained abs = 0.0336375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000931978 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.05337e-05; expected ratio = 1e-07obtained abs = 2.49822e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.12862e-05; expected ratio = 0.0001obtained abs = 0.024261; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000993013 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.61131e-05; expected ratio = 1e-07obtained abs = 1.78531e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.75406e-05; expected ratio = 0.0001obtained abs = 0.0179501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000993013 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.67261e-05; expected ratio = 1e-07obtained abs = 1.32125e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.08814e-05; expected ratio = 0.0001obtained abs = 0.0135226; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000954866 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.01823e-05; expected ratio = 1e-07obtained abs = 9.97744e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.89002e-05; expected ratio = 0.0001obtained abs = 0.0103384; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.14 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.14 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000961065 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.088952; expected ratio = 1e-07obtained abs = 0.000482124; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0457042; expected ratio = 0.0001obtained abs = 12.5374; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000946045 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.02 -Solve flops = 2.460000e+04 Mflops = 1.48 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00681511; expected ratio = 1e-07obtained abs = 3.71575e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.030695; expected ratio = 0.0001obtained abs = 8.2788; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000941992 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00125941; expected ratio = 1e-07obtained abs = 6.87025e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00260539; expected ratio = 0.0001obtained abs = 0.701608; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000974894 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000472845; expected ratio = 1e-07obtained abs = 2.57962e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000604578; expected ratio = 0.0001obtained abs = 0.162774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000961065 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00022082; expected ratio = 1e-07obtained abs = 1.20471e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000290133; expected ratio = 0.0001obtained abs = 0.0781093; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000921965 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.460000e+04 Mflops = 1.48 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000122527; expected ratio = 1e-07obtained abs = 6.68467e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000185452; expected ratio = 0.0001obtained abs = 0.0499257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000952005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.05955e-05; expected ratio = 1e-07obtained abs = 4.39702e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00013178; expected ratio = 0.0001obtained abs = 0.0354762; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000988007 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.95231e-05; expected ratio = 1e-07obtained abs = 3.24738e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.92996e-05; expected ratio = 0.0001obtained abs = 0.0267321; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000938892 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.68004e-05; expected ratio = 1e-07obtained abs = 2.55327e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.82617e-05; expected ratio = 0.0001obtained abs = 0.0210686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000951052 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.80689e-05; expected ratio = 1e-07obtained abs = 2.07691e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.39938e-05; expected ratio = 0.0001obtained abs = 0.0172277; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000963926 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.647520e+05 Mflops = 10.94 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.16157e-05; expected ratio = 1e-07obtained abs = 1.72484e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.38245e-05; expected ratio = 0.0001obtained abs = 0.0144902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.0009408 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.66296e-05; expected ratio = 1e-07obtained abs = 1.45282e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.61749e-05; expected ratio = 0.0001obtained abs = 0.0124309; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000970125 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.26608e-05; expected ratio = 1e-07obtained abs = 1.2363e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.01257e-05; expected ratio = 0.0001obtained abs = 0.0108025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000970125 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.647520e+05 Mflops = 21.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.9433e-05; expected ratio = 1e-07obtained abs = 1.0602e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.51476e-05; expected ratio = 0.0001obtained abs = 0.00946243; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000957966 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.647520e+05 Mflops = 7.30 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.67645e-05; expected ratio = 1e-07obtained abs = 9.14614e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.09337e-05; expected ratio = 0.0001obtained abs = 0.00832806; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.15 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.15 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000869989 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.588320e+05 Mflops = 10.76 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.079838; expected ratio = 1e-07obtained abs = 0.000472481; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0486908; expected ratio = 0.0001obtained abs = 13.4333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000871181 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00672471; expected ratio = 1e-07obtained abs = 3.99795e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0262028; expected ratio = 0.0001obtained abs = 7.13838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000854015 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0018086; expected ratio = 1e-07obtained abs = 1.07569e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00222453; expected ratio = 0.0001obtained abs = 0.605546; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000866175 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00070754; expected ratio = 1e-07obtained abs = 4.20842e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000673565; expected ratio = 0.0001obtained abs = 0.18335; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00090003 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.610360e+05 Mflops = 7.22 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000320884; expected ratio = 1e-07obtained abs = 1.90862e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000327557; expected ratio = 0.0001obtained abs = 0.0891637; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000853062 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000176298; expected ratio = 1e-07obtained abs = 1.04863e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00021167; expected ratio = 0.0001obtained abs = 0.0576182; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000868797 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000116921; expected ratio = 1e-07obtained abs = 6.95447e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000159376; expected ratio = 0.0001obtained abs = 0.0433836; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000890017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.610360e+05 Mflops = 10.83 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.71283e-05; expected ratio = 1e-07obtained abs = 5.18241e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000129257; expected ratio = 0.0001obtained abs = 0.0351855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000886917 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.610360e+05 Mflops = 21.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.889e-05; expected ratio = 1e-07obtained abs = 4.0976e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00010964; expected ratio = 0.0001obtained abs = 0.029846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000926018 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.62597e-05; expected ratio = 1e-07obtained abs = 3.34634e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.56205e-05; expected ratio = 0.0001obtained abs = 0.0260303; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000852108 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.68971e-05; expected ratio = 1e-07obtained abs = 2.78944e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.46942e-05; expected ratio = 0.0001obtained abs = 0.0230565; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00089407 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.610360e+05 Mflops = 7.22 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.96636e-05; expected ratio = 1e-07obtained abs = 2.35919e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.55923e-05; expected ratio = 0.0001obtained abs = 0.0205792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000856876 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.39134e-05; expected ratio = 1e-07obtained abs = 2.01717e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.7694e-05; expected ratio = 0.0001obtained abs = 0.0184295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000891924 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.92439e-05; expected ratio = 1e-07obtained abs = 1.73943e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.06928e-05; expected ratio = 0.0001obtained abs = 0.0165238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000914097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.610360e+05 Mflops = 10.83 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.5388e-05; expected ratio = 1e-07obtained abs = 1.51008e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.44265e-05; expected ratio = 0.0001obtained abs = 0.0148181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000847101 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.610360e+05 Mflops = 10.83 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.21603e-05; expected ratio = 1e-07obtained abs = 1.3181e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.87974e-05; expected ratio = 0.0001obtained abs = 0.0132858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00088501 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.94284e-05; expected ratio = 1e-07obtained abs = 1.1556e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.3736e-05; expected ratio = 0.0001obtained abs = 0.011908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000899076 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.70943e-05; expected ratio = 1e-07obtained abs = 1.01677e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.91862e-05; expected ratio = 0.0001obtained abs = 0.0106694; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000874996 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.610360e+05 Mflops = 10.83 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.50848e-05; expected ratio = 1e-07obtained abs = 8.97244e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.5099e-05; expected ratio = 0.0001obtained abs = 0.00955672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.16 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.16 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00089407 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.566280e+05 Mflops = 21.40 -Solve time = 0.02 -Solve flops = 2.431800e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0726013; expected ratio = 1e-07obtained abs = 0.000465115; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0262905; expected ratio = 0.0001obtained abs = 7.18061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000897169 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.581400e+05 Mflops = 7.16 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00498319; expected ratio = 1e-07obtained abs = 3.20306e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0244707; expected ratio = 0.0001obtained abs = 6.59593; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000897884 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00119607; expected ratio = 1e-07obtained abs = 7.69019e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00170204; expected ratio = 0.0001obtained abs = 0.458351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000902891 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000449949; expected ratio = 1e-07obtained abs = 2.89307e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000462168; expected ratio = 0.0001obtained abs = 0.12444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000846148 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.566280e+05 Mflops = 21.40 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000213771; expected ratio = 1e-07obtained abs = 1.37451e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000234282; expected ratio = 0.0001obtained abs = 0.0630748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000868797 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000128172; expected ratio = 1e-07obtained abs = 8.24121e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000158833; expected ratio = 0.0001obtained abs = 0.0427586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000889063 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.88395e-05; expected ratio = 1e-07obtained abs = 5.7122e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000118867; expected ratio = 0.0001obtained abs = 0.0319976; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000896931 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.56513e-05; expected ratio = 1e-07obtained abs = 4.22124e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.23936e-05; expected ratio = 0.0001obtained abs = 0.02487; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000876904 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.566280e+05 Mflops = 7.13 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.99936e-05; expected ratio = 1e-07obtained abs = 3.21448e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.38094e-05; expected ratio = 0.0001obtained abs = 0.0198668; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000904799 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.87868e-05; expected ratio = 1e-07obtained abs = 2.49391e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.03781e-05; expected ratio = 0.0001obtained abs = 0.0162511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000849009 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.05432e-05; expected ratio = 1e-07obtained abs = 1.96386e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.03706e-05; expected ratio = 0.0001obtained abs = 0.0135572; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000907898 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.566280e+05 Mflops = 10.70 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.4381e-05; expected ratio = 1e-07obtained abs = 1.56764e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.26746e-05; expected ratio = 0.0001obtained abs = 0.0114856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000850916 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.566280e+05 Mflops = 21.40 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.97198e-05; expected ratio = 1e-07obtained abs = 1.26794e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.65799e-05; expected ratio = 0.0001obtained abs = 0.00984506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000862122 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.61562e-05; expected ratio = 1e-07obtained abs = 1.03881e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.16309e-05; expected ratio = 0.0001obtained abs = 0.00851295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000894785 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.34016e-05; expected ratio = 1e-07obtained abs = 8.61694e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.75294e-05; expected ratio = 0.0001obtained abs = 0.00740902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.17 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.17 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000864983 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0668691; expected ratio = 1e-07obtained abs = 0.000460562; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0287218; expected ratio = 0.0001obtained abs = 7.89476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000899792 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.559320e+05 Mflops = 10.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.003143; expected ratio = 1e-07obtained abs = 2.16985e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234887; expected ratio = 0.0001obtained abs = 6.36728; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000864983 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.559320e+05 Mflops = 10.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000512007; expected ratio = 1e-07obtained abs = 3.53537e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00138533; expected ratio = 0.0001obtained abs = 0.375137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000895023 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000225086; expected ratio = 1e-07obtained abs = 1.55422e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000293958; expected ratio = 0.0001obtained abs = 0.0795866; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000840902 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000135505; expected ratio = 1e-07obtained abs = 9.35663e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000158257; expected ratio = 0.0001obtained abs = 0.0428434; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000880957 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.559320e+05 Mflops = 10.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.13806e-05; expected ratio = 1e-07obtained abs = 6.30984e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000105038; expected ratio = 0.0001obtained abs = 0.0284345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000844955 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.48536e-05; expected ratio = 1e-07obtained abs = 4.47814e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.39983e-05; expected ratio = 0.0001obtained abs = 0.0200311; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000895977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.7254e-05; expected ratio = 1e-07obtained abs = 3.26288e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.44929e-05; expected ratio = 0.0001obtained abs = 0.0147507; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000895977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.559320e+05 Mflops = 21.36 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.50073e-05; expected ratio = 1e-07obtained abs = 2.41725e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.17395e-05; expected ratio = 0.0001obtained abs = 0.0112982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000883102 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.559320e+05 Mflops = 10.68 -Solve time = 0.02 -Solve flops = 2.429400e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.62683e-05; expected ratio = 1e-07obtained abs = 1.81382e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.30532e-05; expected ratio = 0.0001obtained abs = 0.00894686; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000892878 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.99388e-05; expected ratio = 1e-07obtained abs = 1.37677e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.68806e-05; expected ratio = 0.0001obtained abs = 0.00727596; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000855207 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.53093e-05; expected ratio = 1e-07obtained abs = 1.0571e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.23147e-05; expected ratio = 0.0001obtained abs = 0.00604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00089097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.559320e+05 Mflops = 21.36 -Solve time = 0.02 -Solve flops = 2.429400e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.18989e-05; expected ratio = 1e-07obtained abs = 8.21615e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.88157e-05; expected ratio = 0.0001obtained abs = 0.0050929; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.18 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.18 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000861883 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0619755; expected ratio = 1e-07obtained abs = 0.000456085; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0233768; expected ratio = 0.0001obtained abs = 6.4114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000818014 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.537280e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00247249; expected ratio = 1e-07obtained abs = 1.82263e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0220563; expected ratio = 0.0001obtained abs = 5.96963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00188899 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000387398; expected ratio = 1e-07obtained abs = 2.85609e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00120987; expected ratio = 0.0001obtained abs = 0.327146; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000179064; expected ratio = 1e-07obtained abs = 1.32016e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000250658; expected ratio = 0.0001obtained abs = 0.0677682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.537280e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000105198; expected ratio = 1e-07obtained abs = 7.7557e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134471; expected ratio = 0.0001obtained abs = 0.0363545; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00051713 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.537280e+05 Mflops = 10.61 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.75586e-05; expected ratio = 1e-07obtained abs = 4.98076e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.71147e-05; expected ratio = 0.0001obtained abs = 0.0235513; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.58943e-05; expected ratio = 1e-07obtained abs = 3.38355e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.99439e-05; expected ratio = 0.0001obtained abs = 0.0162057; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000518084 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.23965e-05; expected ratio = 1e-07obtained abs = 2.38843e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.3802e-05; expected ratio = 0.0001obtained abs = 0.0118418; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.537280e+05 Mflops = 21.22 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.35386e-05; expected ratio = 1e-07obtained abs = 1.73538e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.39113e-05; expected ratio = 0.0001obtained abs = 0.00916789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.537280e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.75233e-05; expected ratio = 1e-07obtained abs = 1.2919e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.74965e-05; expected ratio = 0.0001obtained abs = 0.00743369; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.33404e-05; expected ratio = 1e-07obtained abs = 9.83515e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.30167e-05; expected ratio = 0.0001obtained abs = 0.00622262; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.19 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.19 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.537280e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0577402; expected ratio = 1e-07obtained abs = 0.000451666; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0233957; expected ratio = 0.0001obtained abs = 6.41925; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00205787; expected ratio = 1e-07obtained abs = 1.61168e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0206753; expected ratio = 0.0001obtained abs = 5.60237; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000684023 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000336555; expected ratio = 1e-07obtained abs = 2.63606e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00107195; expected ratio = 0.0001obtained abs = 0.290225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000521183 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000157271; expected ratio = 1e-07obtained abs = 1.23182e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000225067; expected ratio = 0.0001obtained abs = 0.0609289; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.03644e-05; expected ratio = 1e-07obtained abs = 7.07775e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000124665; expected ratio = 0.0001obtained abs = 0.033748; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.64103e-05; expected ratio = 1e-07obtained abs = 4.4183e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.32152e-05; expected ratio = 0.0001obtained abs = 0.0225271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.73238e-05; expected ratio = 1e-07obtained abs = 2.92336e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.92927e-05; expected ratio = 0.0001obtained abs = 0.0160511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.58564e-05; expected ratio = 1e-07obtained abs = 2.02518e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.49362e-05; expected ratio = 0.0001obtained abs = 0.0121648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.86413e-05; expected ratio = 1e-07obtained abs = 1.46007e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.58854e-05; expected ratio = 0.0001obtained abs = 0.00971471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00051713 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.3944e-05; expected ratio = 1e-07obtained abs = 1.09215e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.97467e-05; expected ratio = 0.0001obtained abs = 0.00805295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000516891 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.07963e-05; expected ratio = 1e-07obtained abs = 8.45611e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.52511e-05; expected ratio = 0.0001obtained abs = 0.00683595; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.2 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.2 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0539346; expected ratio = 1e-07obtained abs = 0.00044642; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0214648; expected ratio = 0.0001obtained abs = 5.88552; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00176814; expected ratio = 1e-07obtained abs = 1.46469e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0193157; expected ratio = 0.0001obtained abs = 5.23536; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000308188; expected ratio = 1e-07obtained abs = 2.55315e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000929269; expected ratio = 0.0001obtained abs = 0.251697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00014671; expected ratio = 1e-07obtained abs = 1.2154e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000215553; expected ratio = 0.0001obtained abs = 0.0583795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.44419e-05; expected ratio = 1e-07obtained abs = 6.99546e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134896; expected ratio = 0.0001obtained abs = 0.0365349; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.32568e-05; expected ratio = 1e-07obtained abs = 4.41197e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.87955e-05; expected ratio = 0.0001obtained abs = 0.026758; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000522137 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.61325e-05; expected ratio = 1e-07obtained abs = 2.99333e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.68227e-05; expected ratio = 0.0001obtained abs = 0.0208072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00051713 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.61407e-05; expected ratio = 1e-07obtained abs = 2.16558e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.26245e-05; expected ratio = 0.0001obtained abs = 0.016962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.00118e-05; expected ratio = 1e-07obtained abs = 1.65784e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.2733e-05; expected ratio = 0.0001obtained abs = 0.0142832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000516891 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.60539e-05; expected ratio = 1e-07obtained abs = 1.32995e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.53115e-05; expected ratio = 0.0001obtained abs = 0.0122732; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.33467e-05; expected ratio = 1e-07obtained abs = 1.10568e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.94167e-05; expected ratio = 0.0001obtained abs = 0.0106767; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.13802e-05; expected ratio = 1e-07obtained abs = 9.42771e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.45532e-05; expected ratio = 0.0001obtained abs = 0.00935947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.21 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.21 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000528812 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0505064; expected ratio = 1e-07obtained abs = 0.000440565; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0205417; expected ratio = 0.0001obtained abs = 5.63132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00156088; expected ratio = 1e-07obtained abs = 1.36224e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0180713; expected ratio = 0.0001obtained abs = 4.90152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000522137 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000287936; expected ratio = 1e-07obtained abs = 2.51307e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000806445; expected ratio = 0.0001obtained abs = 0.21861; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000139021; expected ratio = 1e-07obtained abs = 1.21336e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000211662; expected ratio = 0.0001obtained abs = 0.0573746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.99405e-05; expected ratio = 1e-07obtained abs = 6.97709e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000142725; expected ratio = 0.0001obtained abs = 0.0386889; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.02 -Solve flops = 2.428400e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.0583e-05; expected ratio = 1e-07obtained abs = 4.4148e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00010851; expected ratio = 0.0001obtained abs = 0.029415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.46956e-05; expected ratio = 1e-07obtained abs = 3.02817e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.66429e-05; expected ratio = 0.0001obtained abs = 0.023488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.55843e-05; expected ratio = 1e-07obtained abs = 2.23295e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.18771e-05; expected ratio = 0.0001obtained abs = 0.0194856; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000500917 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.00648e-05; expected ratio = 1e-07obtained abs = 1.75121e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.1195e-05; expected ratio = 0.0001obtained abs = 0.0165902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000501156 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.64994e-05; expected ratio = 1e-07obtained abs = 1.44004e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.29732e-05; expected ratio = 0.0001obtained abs = 0.0143615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000516176 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.40217e-05; expected ratio = 1e-07obtained abs = 1.22379e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.63465e-05; expected ratio = 0.0001obtained abs = 0.0125652; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.21719e-05; expected ratio = 1e-07obtained abs = 1.06234e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.0835e-05; expected ratio = 0.0001obtained abs = 0.0110712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.07056e-05; expected ratio = 1e-07obtained abs = 9.34364e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.61536e-05; expected ratio = 0.0001obtained abs = 0.00980211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.22 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.22 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0473851; expected ratio = 1e-07obtained abs = 0.000434034; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.019334; expected ratio = 0.0001obtained abs = 5.29944; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000501871 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00141766; expected ratio = 1e-07obtained abs = 1.29889e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0169182; expected ratio = 0.0001obtained abs = 4.59211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000274755; expected ratio = 1e-07obtained abs = 2.51747e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000702984; expected ratio = 0.0001obtained abs = 0.190723; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.010922 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.02 -Solve flops = 2.428400e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133866; expected ratio = 1e-07obtained abs = 1.22656e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000217947; expected ratio = 0.0001obtained abs = 0.0591296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000516176 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.68681e-05; expected ratio = 1e-07obtained abs = 7.04307e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000154184; expected ratio = 0.0001obtained abs = 0.041832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.88555e-05; expected ratio = 1e-07obtained abs = 4.4764e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000119833; expected ratio = 0.0001obtained abs = 0.0325135; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.39297e-05; expected ratio = 1e-07obtained abs = 3.10881e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.73072e-05; expected ratio = 0.0001obtained abs = 0.0264026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000951052 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.55001e-05; expected ratio = 1e-07obtained abs = 2.33645e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.17382e-05; expected ratio = 0.0001obtained abs = 0.022179; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.04326e-05; expected ratio = 1e-07obtained abs = 1.87214e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.02566e-05; expected ratio = 0.0001obtained abs = 0.0190641; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.71395e-05; expected ratio = 1e-07obtained abs = 1.57041e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.13003e-05; expected ratio = 0.0001obtained abs = 0.0166343; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.48071e-05; expected ratio = 1e-07obtained abs = 1.3567e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.40149e-05; expected ratio = 0.0001obtained abs = 0.0146577; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.30205e-05; expected ratio = 1e-07obtained abs = 1.19301e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.79119e-05; expected ratio = 0.0001obtained abs = 0.0130019; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.15678e-05; expected ratio = 1e-07obtained abs = 1.0599e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.26938e-05; expected ratio = 0.0001obtained abs = 0.0115861; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.0338e-05; expected ratio = 1e-07obtained abs = 9.47222e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.81679e-05; expected ratio = 0.0001obtained abs = 0.010358; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.23 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.23 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000517845 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0445298; expected ratio = 1e-07obtained abs = 0.000426905; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0184105; expected ratio = 0.0001obtained abs = 5.04613; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00132007; expected ratio = 1e-07obtained abs = 1.26564e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0158539; expected ratio = 0.0001obtained abs = 4.30672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000502825 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000265972; expected ratio = 1e-07obtained abs = 2.55016e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000617299; expected ratio = 0.0001obtained abs = 0.167629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000129946; expected ratio = 1e-07obtained abs = 1.24593e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000226807; expected ratio = 0.0001obtained abs = 0.0615905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.4135e-05; expected ratio = 1e-07obtained abs = 7.10809e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000163669; expected ratio = 0.0001obtained abs = 0.0444472; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.69744e-05; expected ratio = 1e-07obtained abs = 4.50392e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000128282; expected ratio = 0.0001obtained abs = 0.0348389; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000499964 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.2694e-05; expected ratio = 1e-07obtained abs = 3.1347e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104975; expected ratio = 0.0001obtained abs = 0.0285103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000499964 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.47472e-05; expected ratio = 1e-07obtained abs = 2.37276e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.87868e-05; expected ratio = 0.0001obtained abs = 0.0241148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.00262e-05; expected ratio = 1e-07obtained abs = 1.92011e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.68025e-05; expected ratio = 0.0001obtained abs = 0.0208605; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.69708e-05; expected ratio = 1e-07obtained abs = 1.62716e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.74276e-05; expected ratio = 0.0001obtained abs = 0.0183148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000500917 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.47966e-05; expected ratio = 1e-07obtained abs = 1.4187e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.97793e-05; expected ratio = 0.0001obtained abs = 0.0162378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000501871 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.31141e-05; expected ratio = 1e-07obtained abs = 1.25738e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.33478e-05; expected ratio = 0.0001obtained abs = 0.0144912; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17296e-05; expected ratio = 1e-07obtained abs = 1.12464e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.78226e-05; expected ratio = 0.0001obtained abs = 0.0129906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.05445e-05; expected ratio = 1e-07obtained abs = 1.011e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.3004e-05; expected ratio = 0.0001obtained abs = 0.0116819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.50585e-06; expected ratio = 1e-07obtained abs = 9.11419e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.87566e-05; expected ratio = 0.0001obtained abs = 0.0105283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.24 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.24 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0419013; expected ratio = 1e-07obtained abs = 0.000419195; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0174814; expected ratio = 0.0001obtained abs = 4.79194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000501871 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00125501; expected ratio = 1e-07obtained abs = 1.25546e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0148651; expected ratio = 0.0001obtained abs = 4.04179; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000260239; expected ratio = 1e-07obtained abs = 2.60342e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000548896; expected ratio = 0.0001obtained abs = 0.149202; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.528920e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00012686; expected ratio = 1e-07obtained abs = 1.2691e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000237637; expected ratio = 0.0001obtained abs = 0.0645969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.550960e+05 Mflops = 21.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.17126e-05; expected ratio = 1e-07obtained abs = 7.17406e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000172403; expected ratio = 0.0001obtained abs = 0.046867; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.51318e-05; expected ratio = 1e-07obtained abs = 4.51494e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000135648; expected ratio = 0.0001obtained abs = 0.0368774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000500917 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.13212e-05; expected ratio = 1e-07obtained abs = 3.13333e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000111638; expected ratio = 0.0001obtained abs = 0.0303514; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.02 -Solve flops = 2.428400e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.37464e-05; expected ratio = 1e-07obtained abs = 2.37556e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.502e-05; expected ratio = 0.0001obtained abs = 0.0258345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.550960e+05 Mflops = 7.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.93118e-05; expected ratio = 1e-07obtained abs = 1.93193e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.27305e-05; expected ratio = 0.0001obtained abs = 0.0224941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.64701e-05; expected ratio = 1e-07obtained abs = 1.64764e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.31078e-05; expected ratio = 0.0001obtained abs = 0.0198784; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.44527e-05; expected ratio = 1e-07obtained abs = 1.44583e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.52333e-05; expected ratio = 0.0001obtained abs = 0.0177379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000899076 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.28856e-05; expected ratio = 1e-07obtained abs = 1.28906e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.85796e-05; expected ratio = 0.0001obtained abs = 0.0159291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000900984 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.550960e+05 Mflops = 10.65 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.15873e-05; expected ratio = 1e-07obtained abs = 1.15918e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.28291e-05; expected ratio = 0.0001obtained abs = 0.0143658; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00089097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.04676e-05; expected ratio = 1e-07obtained abs = 1.04717e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.77807e-05; expected ratio = 0.0001obtained abs = 0.0129933; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.47965e-06; expected ratio = 1e-07obtained abs = 9.48331e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.33005e-05; expected ratio = 0.0001obtained abs = 0.0117752; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.25 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.25 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000512838 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0394705; expected ratio = 1e-07obtained abs = 0.000410948; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0166708; expected ratio = 0.0001obtained abs = 4.57039; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00121168; expected ratio = 1e-07obtained abs = 1.2613e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0139452; expected ratio = 0.0001obtained abs = 3.79521; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.528920e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000256682; expected ratio = 1e-07obtained abs = 2.67201e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000495989; expected ratio = 0.0001obtained abs = 0.134956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.528920e+05 Mflops = 21.17 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000124359; expected ratio = 1e-07obtained abs = 1.29455e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000248545; expected ratio = 0.0001obtained abs = 0.0676309; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000507832 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.94859e-05; expected ratio = 1e-07obtained abs = 7.23331e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000179801; expected ratio = 0.0001obtained abs = 0.0489282; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00050211 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.32518e-05; expected ratio = 1e-07obtained abs = 4.5024e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000141555; expected ratio = 0.0001obtained abs = 0.0385228; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000507116 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.528920e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.97445e-05; expected ratio = 1e-07obtained abs = 3.09633e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000116922; expected ratio = 0.0001obtained abs = 0.031821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.528920e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.24333e-05; expected ratio = 1e-07obtained abs = 2.33525e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100013; expected ratio = 0.0001obtained abs = 0.0272203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000508785 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.82273e-05; expected ratio = 1e-07obtained abs = 1.89742e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.75616e-05; expected ratio = 0.0001obtained abs = 0.0238325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.55775e-05; expected ratio = 1e-07obtained abs = 1.62157e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.78186e-05; expected ratio = 0.0001obtained abs = 0.0211815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000507116 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.528920e+05 Mflops = 21.17 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.37168e-05; expected ratio = 1e-07obtained abs = 1.42788e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.98258e-05; expected ratio = 0.0001obtained abs = 0.0190065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.528920e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.22765e-05; expected ratio = 1e-07obtained abs = 1.27795e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.30403e-05; expected ratio = 0.0001obtained abs = 0.0171601; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.10816e-05; expected ratio = 1e-07obtained abs = 1.15356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.71412e-05; expected ratio = 0.0001obtained abs = 0.0155547; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.00472e-05; expected ratio = 1e-07obtained abs = 1.04588e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.19293e-05; expected ratio = 0.0001obtained abs = 0.0141364; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.13043e-06; expected ratio = 1e-07obtained abs = 9.50452e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.72745e-05; expected ratio = 0.0001obtained abs = 0.0128695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.26 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.26 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0372122; expected ratio = 1e-07obtained abs = 0.000402192; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0159015; expected ratio = 0.0001obtained abs = 4.36047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00050211 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00118253; expected ratio = 1e-07obtained abs = 1.27772e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0130868; expected ratio = 0.0001obtained abs = 3.5651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000515938 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000254627; expected ratio = 1e-07obtained abs = 2.75131e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000458334; expected ratio = 0.0001obtained abs = 0.124841; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506163 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000122294; expected ratio = 1e-07obtained abs = 1.32142e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000259771; expected ratio = 0.0001obtained abs = 0.0707607; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000502825 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.74956e-05; expected ratio = 1e-07obtained abs = 7.29304e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000186856; expected ratio = 0.0001obtained abs = 0.0509026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.14817e-05; expected ratio = 1e-07obtained abs = 4.48218e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00014712; expected ratio = 0.0001obtained abs = 0.0400803; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000502825 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.81745e-05; expected ratio = 1e-07obtained abs = 3.04431e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000121933; expected ratio = 0.0001obtained abs = 0.0332206; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.525800e+05 Mflops = 21.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.10493e-05; expected ratio = 1e-07obtained abs = 2.27442e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104793; expected ratio = 0.0001obtained abs = 0.0285523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000665903 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.70204e-05; expected ratio = 1e-07obtained abs = 1.83909e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.22165e-05; expected ratio = 0.0001obtained abs = 0.0251267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.45314e-05; expected ratio = 1e-07obtained abs = 1.57014e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.23657e-05; expected ratio = 0.0001obtained abs = 0.0224436; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.28096e-05; expected ratio = 1e-07obtained abs = 1.3841e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.42502e-05; expected ratio = 0.0001obtained abs = 0.020233; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.525800e+05 Mflops = 10.58 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.14868e-05; expected ratio = 1e-07obtained abs = 1.24117e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.73193e-05; expected ratio = 0.0001obtained abs = 0.0183449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504017 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.03909e-05; expected ratio = 1e-07obtained abs = 1.12276e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.12538e-05; expected ratio = 0.0001obtained abs = 0.0166926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.00050211 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.44086e-06; expected ratio = 1e-07obtained abs = 1.0201e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.586e-05; expected ratio = 0.0001obtained abs = 0.0152231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000653982 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.525800e+05 Mflops = 21.15 -Solve time = 0.02 -Solve flops = 2.418200e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.59672e-06; expected ratio = 1e-07obtained abs = 9.2889e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.10135e-05; expected ratio = 0.0001obtained abs = 0.0139027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.27 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 140 - - Mesh vertices: 124 - Mesh triangles: 140 - Mesh edges: 227 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.27 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0351057; expected ratio = 1e-07obtained abs = 0.000392961; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.015209; expected ratio = 0.0001obtained abs = 4.17164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.525800e+05 Mflops = 10.58 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00116222; expected ratio = 1e-07obtained abs = 1.30047e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0122853; expected ratio = 0.0001obtained abs = 3.35008; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000253586; expected ratio = 1e-07obtained abs = 2.83761e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000434372; expected ratio = 0.0001obtained abs = 0.118437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000120489; expected ratio = 1e-07obtained abs = 1.34826e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000269595; expected ratio = 0.0001obtained abs = 0.0735142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000507116 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.56127e-05; expected ratio = 1e-07obtained abs = 7.34198e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000192093; expected ratio = 0.0001obtained abs = 0.0523848; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.525800e+05 Mflops = 21.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.9696e-05; expected ratio = 1e-07obtained abs = 4.44193e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000150844; expected ratio = 0.0001obtained abs = 0.0411388; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000511169 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.525800e+05 Mflops = 10.58 -Solve time = 0.02 -Solve flops = 2.418200e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.64759e-05; expected ratio = 1e-07obtained abs = 2.96261e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000125142; expected ratio = 0.0001obtained abs = 0.0341313; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.94476e-05; expected ratio = 1e-07obtained abs = 2.17616e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107823; expected ratio = 0.0001obtained abs = 0.0294091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.55387e-05; expected ratio = 1e-07obtained abs = 1.73875e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.51653e-05; expected ratio = 0.0001obtained abs = 0.025958; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.31806e-05; expected ratio = 1e-07obtained abs = 1.47488e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.52432e-05; expected ratio = 0.0001obtained abs = 0.0232526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000518799 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525800e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.15857e-05; expected ratio = 1e-07obtained abs = 1.29642e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.70364e-05; expected ratio = 0.0001obtained abs = 0.0210148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.03785e-05; expected ratio = 1e-07obtained abs = 1.16134e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.99895e-05; expected ratio = 0.0001obtained abs = 0.0190932; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.38554e-06; expected ratio = 1e-07obtained abs = 1.05023e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.37881e-05; expected ratio = 0.0001obtained abs = 0.017402; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,140) -time: 0.000503778 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.52688e-06; expected ratio = 1e-07obtained abs = 9.54144e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.82451e-05; expected ratio = 0.0001obtained abs = 0.0158903; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.28 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.28 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0773279; expected ratio = 1e-07obtained abs = 0.000890359; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.184948; expected ratio = 0.0001obtained abs = 56.4367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0124013; expected ratio = 1e-07obtained abs = 0.000143245; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0445554; expected ratio = 0.0001obtained abs = 13.3138; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000538111 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527310e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00229719; expected ratio = 1e-07obtained abs = 2.6539e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0073173; expected ratio = 0.0001obtained abs = 2.17435; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528812 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000681591; expected ratio = 1e-07obtained abs = 7.87447e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00143129; expected ratio = 0.0001obtained abs = 0.425036; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000248399; expected ratio = 1e-07obtained abs = 2.86978e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000665808; expected ratio = 0.0001obtained abs = 0.197716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000125265; expected ratio = 1e-07obtained abs = 1.44721e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000485376; expected ratio = 0.0001obtained abs = 0.144151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527310e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.36594e-05; expected ratio = 1e-07obtained abs = 9.66532e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000413095; expected ratio = 0.0001obtained abs = 0.122702; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527859 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.33488e-05; expected ratio = 1e-07obtained abs = 7.31881e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000365796; expected ratio = 0.0001obtained abs = 0.108669; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.04081e-05; expected ratio = 1e-07obtained abs = 5.82376e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000327168; expected ratio = 0.0001obtained abs = 0.0972073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.11406e-05; expected ratio = 1e-07obtained abs = 4.75307e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000293106; expected ratio = 0.0001obtained abs = 0.0870988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.527310e+05 Mflops = 10.58 -Solve time = 0.02 -Solve flops = 2.419400e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.4124e-05; expected ratio = 1e-07obtained abs = 3.94243e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000262253; expected ratio = 0.0001obtained abs = 0.0779403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.527310e+05 Mflops = 10.58 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.86282e-05; expected ratio = 1e-07obtained abs = 3.30749e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000234057; expected ratio = 0.0001obtained abs = 0.0695685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.42181e-05; expected ratio = 1e-07obtained abs = 2.79799e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000208262; expected ratio = 0.0001obtained abs = 0.0619076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.06141e-05; expected ratio = 1e-07obtained abs = 2.38161e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000184724; expected ratio = 0.0001obtained abs = 0.0549158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.527310e+05 Mflops = 10.58 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.7627e-05; expected ratio = 1e-07obtained abs = 2.0365e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000163339; expected ratio = 0.0001obtained abs = 0.0485624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527310e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.51241e-05; expected ratio = 1e-07obtained abs = 1.74733e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000144007; expected ratio = 0.0001obtained abs = 0.0428181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.30093e-05; expected ratio = 1e-07obtained abs = 1.50301e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126622; expected ratio = 0.0001obtained abs = 0.0376513; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.12113e-05; expected ratio = 1e-07obtained abs = 1.29527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000111063; expected ratio = 0.0001obtained abs = 0.0330267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.527310e+05 Mflops = 21.16 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.67513e-06; expected ratio = 1e-07obtained abs = 1.1178e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.72025e-05; expected ratio = 0.0001obtained abs = 0.0289064; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527859 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527310e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.35816e-06; expected ratio = 1e-07obtained abs = 9.65644e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.49059e-05; expected ratio = 0.0001obtained abs = 0.0252508; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.29 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.29 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.504750e+05 Mflops = 7.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0334998; expected ratio = 1e-07obtained abs = 0.000396707; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.231353; expected ratio = 0.0001obtained abs = 61.2246; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528812 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0029212; expected ratio = 1e-07obtained abs = 3.45878e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0137488; expected ratio = 0.0001obtained abs = 3.61449; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000631959; expected ratio = 1e-07obtained abs = 7.48302e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00187571; expected ratio = 0.0001obtained abs = 0.49248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000207728; expected ratio = 1e-07obtained abs = 2.4597e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000696252; expected ratio = 0.0001obtained abs = 0.182718; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000529051 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.522830e+05 Mflops = 21.14 -Solve time = 0.02 -Solve flops = 2.419800e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000111896; expected ratio = 1e-07obtained abs = 1.32495e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000534723; expected ratio = 0.0001obtained abs = 0.140285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527859 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.65402e-05; expected ratio = 1e-07obtained abs = 9.06303e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000468208; expected ratio = 0.0001obtained abs = 0.122803; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.83481e-05; expected ratio = 1e-07obtained abs = 6.9089e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000417561; expected ratio = 0.0001obtained abs = 0.109495; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00052619 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.75067e-05; expected ratio = 1e-07obtained abs = 5.62518e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0003742; expected ratio = 0.0001obtained abs = 0.0981049; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000655174 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.522830e+05 Mflops = 21.14 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.03399e-05; expected ratio = 1e-07obtained abs = 4.77657e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000336183; expected ratio = 0.0001obtained abs = 0.0881218; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000753164 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.5174e-05; expected ratio = 1e-07obtained abs = 4.16487e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000302633; expected ratio = 0.0001obtained abs = 0.0793143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527859 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.11908e-05; expected ratio = 1e-07obtained abs = 3.69323e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000272917; expected ratio = 0.0001obtained abs = 0.0715158; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.7965e-05; expected ratio = 1e-07obtained abs = 3.31127e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000246513; expected ratio = 0.0001obtained abs = 0.0645881; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.52594e-05; expected ratio = 1e-07obtained abs = 2.9909e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000222978; expected ratio = 0.0001obtained abs = 0.0584147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000541925 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.29319e-05; expected ratio = 1e-07obtained abs = 2.71531e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00020194; expected ratio = 0.0001obtained abs = 0.0528971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.08925e-05; expected ratio = 1e-07obtained abs = 2.47383e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000183083; expected ratio = 0.0001obtained abs = 0.0479529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.90811e-05; expected ratio = 1e-07obtained abs = 2.25935e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000166143; expected ratio = 0.0001obtained abs = 0.0435121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.7456e-05; expected ratio = 1e-07obtained abs = 2.06692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000150895; expected ratio = 0.0001obtained abs = 0.0395153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527143 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.59873e-05; expected ratio = 1e-07obtained abs = 1.89302e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000137145; expected ratio = 0.0001obtained abs = 0.0359118; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.4653e-05; expected ratio = 1e-07obtained abs = 1.73502e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000124727; expected ratio = 0.0001obtained abs = 0.032658; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.34361e-05; expected ratio = 1e-07obtained abs = 1.59094e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113498; expected ratio = 0.0001obtained abs = 0.0297159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.23235e-05; expected ratio = 1e-07obtained abs = 1.45919e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103332; expected ratio = 0.0001obtained abs = 0.0270527; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.02 -Solve flops = 2.419800e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.13043e-05; expected ratio = 1e-07obtained abs = 1.33851e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.41181e-05; expected ratio = 0.0001obtained abs = 0.0246393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.03695e-05; expected ratio = 1e-07obtained abs = 1.22783e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.57607e-05; expected ratio = 0.0001obtained abs = 0.0224503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.51166e-06; expected ratio = 1e-07obtained abs = 1.12625e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.81736e-05; expected ratio = 0.0001obtained abs = 0.0204633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.72397e-06; expected ratio = 1e-07obtained abs = 1.03298e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.12809e-05; expected ratio = 0.0001obtained abs = 0.0186583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.00057e-06; expected ratio = 1e-07obtained abs = 9.47327e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.5015e-05; expected ratio = 0.0001obtained abs = 0.0170175; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.3 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.3 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0271411; expected ratio = 1e-07obtained abs = 0.00032836; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.180165; expected ratio = 0.0001obtained abs = 54.4123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.522830e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00357686; expected ratio = 1e-07obtained abs = 4.32518e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00988497; expected ratio = 0.0001obtained abs = 2.9938; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00103368; expected ratio = 1e-07obtained abs = 1.24998e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00255581; expected ratio = 0.0001obtained abs = 0.77477; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000529051 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000359018; expected ratio = 1e-07obtained abs = 4.34144e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00182669; expected ratio = 0.0001obtained abs = 0.553461; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000171154; expected ratio = 1e-07obtained abs = 2.0697e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000644008; expected ratio = 0.0001obtained abs = 0.19517; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000110637; expected ratio = 1e-07obtained abs = 1.3379e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000510427; expected ratio = 0.0001obtained abs = 0.154715; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.522830e+05 Mflops = 10.57 -Solve time = 0.02 -Solve flops = 2.419800e+04 Mflops = 1.45 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.12162e-05; expected ratio = 1e-07obtained abs = 9.82123e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000445717; expected ratio = 0.0001obtained abs = 0.135123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.26398e-05; expected ratio = 1e-07obtained abs = 7.57486e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00039635; expected ratio = 0.0001obtained abs = 0.120176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.96214e-05; expected ratio = 1e-07obtained abs = 6.00059e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000353124; expected ratio = 0.0001obtained abs = 0.107086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00052619 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.513150e+05 Mflops = 21.08 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.00292e-05; expected ratio = 1e-07obtained abs = 4.84064e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000313472; expected ratio = 0.0001obtained abs = 0.0950747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000542164 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.513150e+05 Mflops = 10.54 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.27226e-05; expected ratio = 1e-07obtained abs = 3.95707e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000276717; expected ratio = 0.0001obtained abs = 0.0839378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.70143e-05; expected ratio = 1e-07obtained abs = 3.26678e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000242785; expected ratio = 0.0001obtained abs = 0.0736535; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.24657e-05; expected ratio = 1e-07obtained abs = 2.71673e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000211751; expected ratio = 0.0001obtained abs = 0.0642455; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00052619 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.51961e-05; expected ratio = 1e-07obtained abs = 3.04692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00144607; expected ratio = 0.0001obtained abs = 0.438674; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527859 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.513150e+05 Mflops = 7.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.71856e-05; expected ratio = 1e-07obtained abs = 2.07822e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000241991; expected ratio = 0.0001obtained abs = 0.0734194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00052619 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.40171e-05; expected ratio = 1e-07obtained abs = 1.69507e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000149841; expected ratio = 0.0001obtained abs = 0.0454654; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17452e-05; expected ratio = 1e-07obtained abs = 1.42033e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000125493; expected ratio = 0.0001obtained abs = 0.03808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.91549e-06; expected ratio = 1e-07obtained abs = 1.19906e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107217; expected ratio = 0.0001obtained abs = 0.0325361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00052309 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.513150e+05 Mflops = 7.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.39559e-06; expected ratio = 1e-07obtained abs = 1.01527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.14376e-05; expected ratio = 0.0001obtained abs = 0.0277491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528812 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.513150e+05 Mflops = 21.08 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.12103e-06; expected ratio = 1e-07obtained abs = 8.61135e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.77487e-05; expected ratio = 0.0001obtained abs = 0.0235958; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.31 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.31 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000534058 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.510790e+05 Mflops = 10.53 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0243215; expected ratio = 1e-07obtained abs = 0.000300231; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.155486; expected ratio = 0.0001obtained abs = 41.8488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00247449; expected ratio = 1e-07obtained abs = 3.05313e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00929503; expected ratio = 0.0001obtained abs = 2.50199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000662736; expected ratio = 1e-07obtained abs = 8.17728e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000843758; expected ratio = 0.0001obtained abs = 0.227088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00021357; expected ratio = 1e-07obtained abs = 2.63515e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000402553; expected ratio = 0.0001obtained abs = 0.108325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.33015e-05; expected ratio = 1e-07obtained abs = 1.02782e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000294254; expected ratio = 0.0001obtained abs = 0.07917; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.520470e+05 Mflops = 21.12 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.11501e-05; expected ratio = 1e-07obtained abs = 5.07732e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000246536; expected ratio = 0.0001obtained abs = 0.0663224; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.54117e-05; expected ratio = 1e-07obtained abs = 3.13543e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000212084; expected ratio = 0.0001obtained abs = 0.0570476; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.83334e-05; expected ratio = 1e-07obtained abs = 2.26208e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000183395; expected ratio = 0.0001obtained abs = 0.0493258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.44078e-05; expected ratio = 1e-07obtained abs = 1.77771e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000158757; expected ratio = 0.0001obtained abs = 0.0426954; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.18131e-05; expected ratio = 1e-07obtained abs = 1.45757e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00013753; expected ratio = 0.0001obtained abs = 0.0369839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00052619 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.89586e-06; expected ratio = 1e-07obtained abs = 1.221e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000119263; expected ratio = 0.0001obtained abs = 0.0320695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527143 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.38995e-06; expected ratio = 1e-07obtained abs = 1.03519e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103549; expected ratio = 0.0001obtained abs = 0.0278426; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.520470e+05 Mflops = 21.12 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.63163e-05; expected ratio = 1e-07obtained abs = 2.01319e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00170053; expected ratio = 0.0001obtained abs = 0.457366; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.97939e-06; expected ratio = 1e-07obtained abs = 1.10792e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000362788; expected ratio = 0.0001obtained abs = 0.0975617; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.78562e-06; expected ratio = 1e-07obtained abs = 8.37243e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131459; expected ratio = 0.0001obtained abs = 0.0353497; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.32 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.32 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000529051 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0225766; expected ratio = 1e-07obtained abs = 0.000283924; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.102476; expected ratio = 0.0001obtained abs = 30.0192; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00232634; expected ratio = 1e-07obtained abs = 2.92408e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00805259; expected ratio = 0.0001obtained abs = 2.35972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000522852 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000662053; expected ratio = 1e-07obtained abs = 8.32176e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000796934; expected ratio = 0.0001obtained abs = 0.233488; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.520470e+05 Mflops = 21.12 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000238381; expected ratio = 1e-07obtained abs = 2.99635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000373427; expected ratio = 0.0001obtained abs = 0.109389; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527859 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000102924; expected ratio = 1e-07obtained abs = 1.29371e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000234388; expected ratio = 0.0001obtained abs = 0.0686511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00052619 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.14562e-05; expected ratio = 1e-07obtained abs = 6.46781e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000173496; expected ratio = 0.0001obtained abs = 0.0508109; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527143 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.86197e-05; expected ratio = 1e-07obtained abs = 3.59737e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000137955; expected ratio = 0.0001obtained abs = 0.0403988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000521898 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.7456e-05; expected ratio = 1e-07obtained abs = 2.19414e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113602; expected ratio = 0.0001obtained abs = 0.0332651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.520470e+05 Mflops = 7.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.16746e-05; expected ratio = 1e-07obtained abs = 1.46744e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.53916e-05; expected ratio = 0.0001obtained abs = 0.027931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.51928e-06; expected ratio = 1e-07obtained abs = 1.07084e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.11161e-05; expected ratio = 0.0001obtained abs = 0.02375; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.67057e-06; expected ratio = 1e-07obtained abs = 8.38461e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.95995e-05; expected ratio = 0.0001obtained abs = 0.0203772; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.33 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.33 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0204905; expected ratio = 1e-07obtained abs = 0.00026227; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0807644; expected ratio = 0.0001obtained abs = 22.0655; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00201032; expected ratio = 1e-07obtained abs = 2.57191e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00800268; expected ratio = 0.0001obtained abs = 2.18441; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000523806 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000582802; expected ratio = 1e-07obtained abs = 7.45616e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000793062; expected ratio = 0.0001obtained abs = 0.216414; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530005 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.517390e+05 Mflops = 7.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000213398; expected ratio = 1e-07obtained abs = 2.73012e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000367458; expected ratio = 0.0001obtained abs = 0.100256; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.29526e-05; expected ratio = 1e-07obtained abs = 1.18919e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000255563; expected ratio = 0.0001obtained abs = 0.0697174; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527143 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.77263e-05; expected ratio = 1e-07obtained abs = 6.10585e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00021785; expected ratio = 0.0001obtained abs = 0.0594221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.87938e-05; expected ratio = 1e-07obtained abs = 3.68373e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000194452; expected ratio = 0.0001obtained abs = 0.0530345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.533430e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.02885e-05; expected ratio = 1e-07obtained abs = 2.59561e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000174738; expected ratio = 0.0001obtained abs = 0.0476534; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00067091 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.533430e+05 Mflops = 21.20 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.60608e-05; expected ratio = 1e-07obtained abs = 2.05473e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000156931; expected ratio = 0.0001obtained abs = 0.0427936; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.3583e-05; expected ratio = 1e-07obtained abs = 1.73773e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000140786; expected ratio = 0.0001obtained abs = 0.0383883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000527143 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.18623e-05; expected ratio = 1e-07obtained abs = 1.51759e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126241; expected ratio = 0.0001obtained abs = 0.0344199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528812 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.533430e+05 Mflops = 10.60 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.05185e-05; expected ratio = 1e-07obtained abs = 1.34567e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113203; expected ratio = 0.0001obtained abs = 0.0308633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.533430e+05 Mflops = 10.60 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.39848e-06; expected ratio = 1e-07obtained abs = 1.20239e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00010155; expected ratio = 0.0001obtained abs = 0.0276849; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.43322e-06; expected ratio = 1e-07obtained abs = 1.0789e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.11465e-05; expected ratio = 0.0001obtained abs = 0.0248474; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.58631e-06; expected ratio = 1e-07obtained abs = 9.7055e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.18583e-05; expected ratio = 0.0001obtained abs = 0.0223144; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.34 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.34 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0191814; expected ratio = 1e-07obtained abs = 0.000249571; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0567531; expected ratio = 0.0001obtained abs = 16.2612; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0018761; expected ratio = 1e-07obtained abs = 2.43985e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00727299; expected ratio = 0.0001obtained abs = 2.08346; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000523806 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.533430e+05 Mflops = 7.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000535095; expected ratio = 1e-07obtained abs = 6.95891e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000779593; expected ratio = 0.0001obtained abs = 0.223305; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000529051 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.533430e+05 Mflops = 10.60 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00019274; expected ratio = 1e-07obtained abs = 2.50656e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000317927; expected ratio = 0.0001obtained abs = 0.0910641; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.15982e-05; expected ratio = 1e-07obtained abs = 1.06118e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000154244; expected ratio = 0.0001obtained abs = 0.04418; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.94324e-05; expected ratio = 1e-07obtained abs = 5.12813e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.01808e-05; expected ratio = 0.0001obtained abs = 0.0258306; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.533430e+05 Mflops = 21.20 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.10132e-05; expected ratio = 1e-07obtained abs = 2.73273e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.12223e-05; expected ratio = 0.0001obtained abs = 0.0175361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.542170e+05 Mflops = 7.08 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.21877e-05; expected ratio = 1e-07obtained abs = 1.58499e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.6373e-05; expected ratio = 0.0001obtained abs = 0.0132829; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000529051 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.7039e-06; expected ratio = 1e-07obtained abs = 1.00188e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.76885e-05; expected ratio = 0.0001obtained abs = 0.0107955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.30749e-06; expected ratio = 1e-07obtained abs = 6.90231e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.19574e-05; expected ratio = 0.0001obtained abs = 0.00915395; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.35 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 141 - - Mesh vertices: 124 - Mesh triangles: 141 - Mesh edges: 228 - Mesh exterior boundary edges: 33 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 33 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.35 -matrix_partition : [9](0,28,56,84,112,140,168,196,226) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.00053215 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0179183; expected ratio = 1e-07obtained abs = 0.000236731; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0409299; expected ratio = 0.0001obtained abs = 11.3046; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00172917; expected ratio = 1e-07obtained abs = 2.28351e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00713116; expected ratio = 0.0001obtained abs = 1.96908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.543630e+05 Mflops = 21.26 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000480125; expected ratio = 1e-07obtained abs = 6.3405e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000819051; expected ratio = 0.0001obtained abs = 0.226137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000524998 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.543630e+05 Mflops = 7.09 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000168925; expected ratio = 1e-07obtained abs = 2.2308e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000326565; expected ratio = 0.0001obtained abs = 0.0901629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000528097 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.94173e-05; expected ratio = 1e-07obtained abs = 9.16713e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000147985; expected ratio = 0.0001obtained abs = 0.0408582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.22805e-05; expected ratio = 1e-07obtained abs = 4.26291e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.57058e-05; expected ratio = 0.0001obtained abs = 0.0209022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000525951 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.62977e-05; expected ratio = 1e-07obtained abs = 2.15225e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.27468e-05; expected ratio = 0.0001obtained abs = 0.0118024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000537157 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.543630e+05 Mflops = 10.63 -Solve time = 0.02 -Solve flops = 2.426200e+04 Mflops = 1.46 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.73416e-06; expected ratio = 1e-07obtained abs = 1.15342e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.66644e-05; expected ratio = 0.0001obtained abs = 0.00736211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,141) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 226 -RHS size in solver: 226 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.95423e-06; expected ratio = 1e-07obtained abs = 6.54247e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.83699e-05; expected ratio = 0.0001obtained abs = 0.005072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.36 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.36 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.525780e+05 Mflops = 7.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0200908; expected ratio = 1e-07obtained abs = 0.000268238; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.137357; expected ratio = 0.0001obtained abs = 39.4888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179017; expected ratio = 1e-07obtained abs = 2.38966e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00661522; expected ratio = 0.0001obtained abs = 1.90464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00046059; expected ratio = 1e-07obtained abs = 6.14841e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000894238; expected ratio = 0.0001obtained abs = 0.257427; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000156819; expected ratio = 1e-07obtained abs = 2.09337e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000344851; expected ratio = 0.0001obtained abs = 0.099273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000562906 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.527760e+05 Mflops = 10.58 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.61865e-05; expected ratio = 1e-07obtained abs = 8.83519e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000178742; expected ratio = 0.0001obtained abs = 0.0514559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.42582e-05; expected ratio = 1e-07obtained abs = 4.5731e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000116129; expected ratio = 0.0001obtained abs = 0.0334318; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.10457e-05; expected ratio = 1e-07obtained abs = 2.80938e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.73751e-05; expected ratio = 0.0001obtained abs = 0.0251545; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.47734e-05; expected ratio = 1e-07obtained abs = 1.9721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.10816e-05; expected ratio = 0.0001obtained abs = 0.0204643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.527760e+05 Mflops = 7.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.1351e-05; expected ratio = 1e-07obtained abs = 1.51524e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.00012e-05; expected ratio = 0.0001obtained abs = 0.0172746; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.527760e+05 Mflops = 21.17 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.19438e-06; expected ratio = 1e-07obtained abs = 1.22735e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.1504e-05; expected ratio = 0.0001obtained abs = 0.0148285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547171 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.66112e-06; expected ratio = 1e-07obtained abs = 1.02268e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.45344e-05; expected ratio = 0.0001obtained abs = 0.0128221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.47864e-06; expected ratio = 1e-07obtained abs = 8.64832e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.86187e-05; expected ratio = 0.0001obtained abs = 0.0111191; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.37 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.37 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0164292; expected ratio = 1e-07obtained abs = 0.000221016; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0588682; expected ratio = 0.0001obtained abs = 16.4004; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000692844 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00162055; expected ratio = 1e-07obtained abs = 2.17955e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00666053; expected ratio = 0.0001obtained abs = 1.85905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.503760e+05 Mflops = 7.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0004314; expected ratio = 1e-07obtained abs = 5.80215e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000962286; expected ratio = 0.0001obtained abs = 0.26863; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000152998; expected ratio = 1e-07obtained abs = 2.05776e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000365827; expected ratio = 0.0001obtained abs = 0.102129; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.57678e-05; expected ratio = 1e-07obtained abs = 1.01904e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000183807; expected ratio = 0.0001obtained abs = 0.051315; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.71112e-05; expected ratio = 1e-07obtained abs = 6.33621e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000117371; expected ratio = 0.0001obtained abs = 0.0327677; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000607967 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.503760e+05 Mflops = 7.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.24984e-05; expected ratio = 1e-07obtained abs = 4.37086e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.58545e-05; expected ratio = 0.0001obtained abs = 0.0239691; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.0005548 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.503760e+05 Mflops = 21.02 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.35413e-05; expected ratio = 1e-07obtained abs = 3.16617e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.68731e-05; expected ratio = 0.0001obtained abs = 0.0186699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.75158e-05; expected ratio = 1e-07obtained abs = 2.35578e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.35123e-05; expected ratio = 0.0001obtained abs = 0.0149399; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.3248e-05; expected ratio = 1e-07obtained abs = 1.78179e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.33332e-05; expected ratio = 0.0001obtained abs = 0.0120981; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.503760e+05 Mflops = 7.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.013e-05; expected ratio = 1e-07obtained abs = 1.36243e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.52935e-05; expected ratio = 0.0001obtained abs = 0.00985354; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.503760e+05 Mflops = 10.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.80675e-06; expected ratio = 1e-07obtained abs = 1.04997e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.88407e-05; expected ratio = 0.0001obtained abs = 0.00805203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.05311e-06; expected ratio = 1e-07obtained abs = 8.14111e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.3623e-05; expected ratio = 0.0001obtained abs = 0.00659532; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.38 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.38 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.490880e+05 Mflops = 20.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0117315; expected ratio = 1e-07obtained abs = 0.000158811; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0320019; expected ratio = 0.0001obtained abs = 9.12194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00157193; expected ratio = 1e-07obtained abs = 2.12757e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00601422; expected ratio = 0.0001obtained abs = 1.71843; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000406874; expected ratio = 1e-07obtained abs = 5.50697e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00261617; expected ratio = 0.0001obtained abs = 0.74793; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.490880e+05 Mflops = 6.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000142697; expected ratio = 1e-07obtained abs = 1.93138e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000440656; expected ratio = 0.0001obtained abs = 0.125998; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.490880e+05 Mflops = 10.47 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.51361e-05; expected ratio = 1e-07obtained abs = 1.01695e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000236741; expected ratio = 0.0001obtained abs = 0.0676969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.08182e-05; expected ratio = 1e-07obtained abs = 6.87807e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000163156; expected ratio = 0.0001obtained abs = 0.0466575; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.78947e-05; expected ratio = 1e-07obtained abs = 5.1289e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000123903; expected ratio = 0.0001obtained abs = 0.0354339; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.490880e+05 Mflops = 10.47 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.94451e-05; expected ratio = 1e-07obtained abs = 3.98528e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.81358e-05; expected ratio = 0.0001obtained abs = 0.0280657; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.490880e+05 Mflops = 6.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.33798e-05; expected ratio = 1e-07obtained abs = 3.16436e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.92417e-05; expected ratio = 0.0001obtained abs = 0.0226628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.88117e-05; expected ratio = 1e-07obtained abs = 2.54609e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.46208e-05; expected ratio = 0.0001obtained abs = 0.0184817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.52733e-05; expected ratio = 1e-07obtained abs = 2.06717e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.29998e-05; expected ratio = 0.0001obtained abs = 0.0151583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.490880e+05 Mflops = 20.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.24825e-05; expected ratio = 1e-07obtained abs = 1.68944e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.36323e-05; expected ratio = 0.0001obtained abs = 0.0124793; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.490880e+05 Mflops = 6.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.02538e-05; expected ratio = 1e-07obtained abs = 1.3878e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.60207e-05; expected ratio = 0.0001obtained abs = 0.0103024; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.45774e-06; expected ratio = 1e-07obtained abs = 1.14471e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.98053e-05; expected ratio = 0.0001obtained abs = 0.00852481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.00018e-06; expected ratio = 1e-07obtained abs = 9.4744e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.47128e-05; expected ratio = 0.0001obtained abs = 0.00706832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.39 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.39 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0100688; expected ratio = 1e-07obtained abs = 0.000137024; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0296419; expected ratio = 0.0001obtained abs = 8.2997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00163073; expected ratio = 1e-07obtained abs = 2.21892e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0044206; expected ratio = 0.0001obtained abs = 1.23956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.0005548 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.983120e+05 Mflops = 11.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0005326; expected ratio = 1e-07obtained abs = 7.2471e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00151499; expected ratio = 0.0001obtained abs = 0.424722; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983120e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000235839; expected ratio = 1e-07obtained abs = 3.20905e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000660858; expected ratio = 0.0001obtained abs = 0.185254; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000125337; expected ratio = 1e-07obtained abs = 1.70545e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000342346; expected ratio = 0.0001obtained abs = 0.0959627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.38595e-05; expected ratio = 1e-07obtained abs = 1.005e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000192717; expected ratio = 0.0001obtained abs = 0.0540187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000597 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983120e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.68786e-05; expected ratio = 1e-07obtained abs = 6.37871e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000118293; expected ratio = 0.0001obtained abs = 0.0331571; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.983120e+05 Mflops = 11.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.19014e-05; expected ratio = 1e-07obtained abs = 4.34078e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.96412e-05; expected ratio = 0.0001obtained abs = 0.0223228; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.31986e-05; expected ratio = 1e-07obtained abs = 3.1566e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.84649e-05; expected ratio = 0.0001obtained abs = 0.0163872; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.78296e-05; expected ratio = 1e-07obtained abs = 2.42604e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.58582e-05; expected ratio = 0.0001obtained abs = 0.0128536; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983120e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.42557e-05; expected ratio = 1e-07obtained abs = 1.93974e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.75333e-05; expected ratio = 0.0001obtained abs = 0.0105201; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983120e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.16879e-05; expected ratio = 1e-07obtained abs = 1.59035e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.14802e-05; expected ratio = 0.0001obtained abs = 0.00882352; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.72635e-06; expected ratio = 1e-07obtained abs = 1.32344e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.67579e-05; expected ratio = 0.0001obtained abs = 0.00749988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.16412e-06; expected ratio = 1e-07obtained abs = 1.11087e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.29072e-05; expected ratio = 0.0001obtained abs = 0.00642058; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000676155 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983120e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.88753e-06; expected ratio = 1e-07obtained abs = 9.3717e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.96859e-05; expected ratio = 0.0001obtained abs = 0.00551768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.4 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.4 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 4.002960e+05 Mflops = 24.02 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00990712; expected ratio = 1e-07obtained abs = 0.000135363; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0234274; expected ratio = 0.0001obtained abs = 6.68184; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000562906 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 4.002960e+05 Mflops = 8.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00172584; expected ratio = 1e-07obtained abs = 2.35788e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00459053; expected ratio = 0.0001obtained abs = 1.31212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000599016; expected ratio = 1e-07obtained abs = 8.18394e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00170066; expected ratio = 0.0001obtained abs = 0.485935; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000586033 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000281069; expected ratio = 1e-07obtained abs = 3.84006e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000805492; expected ratio = 0.0001obtained abs = 0.230121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.983060e+05 Mflops = 11.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000155206; expected ratio = 1e-07obtained abs = 2.12048e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000442265; expected ratio = 0.0001obtained abs = 0.12634; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.22146e-05; expected ratio = 1e-07obtained abs = 1.25987e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000257674; expected ratio = 0.0001obtained abs = 0.0736056; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.67043e-05; expected ratio = 1e-07obtained abs = 7.74714e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000156986; expected ratio = 0.0001obtained abs = 0.0448427; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.55571e-05; expected ratio = 1e-07obtained abs = 4.85793e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.9141e-05; expected ratio = 0.0001obtained abs = 0.028319; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.983060e+05 Mflops = 11.95 -Solve time = 0.02 -Solve flops = 2.540600e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.26034e-05; expected ratio = 1e-07obtained abs = 3.08815e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.45944e-05; expected ratio = 0.0001obtained abs = 0.0184509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.45357e-05; expected ratio = 1e-07obtained abs = 1.98592e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.33007e-05; expected ratio = 0.0001obtained abs = 0.0123685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.45479e-06; expected ratio = 1e-07obtained abs = 1.29175e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.98052e-05; expected ratio = 0.0001obtained abs = 0.00851361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.2278e-06; expected ratio = 1e-07obtained abs = 8.50863e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.10254e-05; expected ratio = 0.0001obtained abs = 0.00600574; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.41 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.41 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00847074; expected ratio = 1e-07obtained abs = 0.000116092; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0285377; expected ratio = 0.0001obtained abs = 7.94868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00148005; expected ratio = 1e-07obtained abs = 2.02834e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00390644; expected ratio = 0.0001obtained abs = 1.08991; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000484912; expected ratio = 1e-07obtained abs = 6.64554e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118398; expected ratio = 0.0001obtained abs = 0.330212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000215217; expected ratio = 1e-07obtained abs = 2.94948e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000533777; expected ratio = 0.0001obtained abs = 0.148845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551224 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000115171; expected ratio = 1e-07obtained abs = 1.57838e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000305188; expected ratio = 0.0001obtained abs = 0.085093; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.82663e-05; expected ratio = 1e-07obtained abs = 9.35569e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000190589; expected ratio = 0.0001obtained abs = 0.0531361; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.28787e-05; expected ratio = 1e-07obtained abs = 5.8764e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000125176; expected ratio = 0.0001obtained abs = 0.0348972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.80528e-05; expected ratio = 1e-07obtained abs = 3.84456e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.49712e-05; expected ratio = 0.0001obtained abs = 0.0236878; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.9024e-05; expected ratio = 1e-07obtained abs = 2.60719e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.9247e-05; expected ratio = 0.0001obtained abs = 0.0165162; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.33761e-05; expected ratio = 1e-07obtained abs = 1.83316e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.23791e-05; expected ratio = 0.0001obtained abs = 0.0118137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000565052 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.540600e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.76009e-06; expected ratio = 1e-07obtained abs = 1.3376e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.11069e-05; expected ratio = 0.0001obtained abs = 0.00867134; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.3809e-06; expected ratio = 1e-07obtained abs = 1.01153e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.34314e-05; expected ratio = 0.0001obtained abs = 0.00653166; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.75987e-06; expected ratio = 1e-07obtained abs = 7.89376e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.80922e-05; expected ratio = 0.0001obtained abs = 0.00504329; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.42 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.42 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00775041; expected ratio = 1e-07obtained abs = 0.000106439; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142258; expected ratio = 0.0001obtained abs = 4.00581; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547171 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00131267; expected ratio = 1e-07obtained abs = 1.80269e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00364818; expected ratio = 0.0001obtained abs = 1.02911; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547171 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000398799; expected ratio = 1e-07obtained abs = 5.47675e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000954252; expected ratio = 0.0001obtained abs = 0.269114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.983060e+05 Mflops = 11.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000165901; expected ratio = 1e-07obtained abs = 2.27834e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000392447; expected ratio = 0.0001obtained abs = 0.110664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.65881e-05; expected ratio = 1e-07obtained abs = 1.18912e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000213; expected ratio = 0.0001obtained abs = 0.0600584; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.19676e-05; expected ratio = 1e-07obtained abs = 7.13679e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000132695; expected ratio = 0.0001obtained abs = 0.0374132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.38677e-05; expected ratio = 1e-07obtained abs = 4.65111e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.94367e-05; expected ratio = 0.0001obtained abs = 0.0252157; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983060e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.33512e-05; expected ratio = 1e-07obtained abs = 3.20686e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.30366e-05; expected ratio = 0.0001obtained abs = 0.017772; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.68262e-05; expected ratio = 1e-07obtained abs = 2.31077e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.58235e-05; expected ratio = 0.0001obtained abs = 0.0129189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.25777e-05; expected ratio = 1e-07obtained abs = 1.72732e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.42006e-05; expected ratio = 0.0001obtained abs = 0.00964194; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.983060e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.540600e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.69324e-06; expected ratio = 1e-07obtained abs = 1.33119e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.61651e-05; expected ratio = 0.0001obtained abs = 0.00737648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552177 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.983060e+05 Mflops = 23.90 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.65546e-06; expected ratio = 1e-07obtained abs = 1.05134e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.04861e-05; expected ratio = 0.0001obtained abs = 0.00577542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.16088e-06; expected ratio = 1e-07obtained abs = 8.46088e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.63741e-05; expected ratio = 0.0001obtained abs = 0.00461615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.43 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.43 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0150835; expected ratio = 1e-07obtained abs = 0.000207017; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0300616; expected ratio = 0.0001obtained abs = 8.50792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00239385; expected ratio = 1e-07obtained abs = 3.28496e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00626358; expected ratio = 0.0001obtained abs = 1.78091; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.970460e+05 Mflops = 23.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000649406; expected ratio = 1e-07obtained abs = 8.91148e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00243864; expected ratio = 0.0001obtained abs = 0.693409; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.970460e+05 Mflops = 7.94 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000255545; expected ratio = 1e-07obtained abs = 3.50674e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000520302; expected ratio = 0.0001obtained abs = 0.147945; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000152673; expected ratio = 1e-07obtained abs = 2.09509e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000309585; expected ratio = 0.0001obtained abs = 0.0880264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547171 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00011001; expected ratio = 1e-07obtained abs = 1.50965e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000220341; expected ratio = 0.0001obtained abs = 0.0626492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.993060e+05 Mflops = 11.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.39811e-05; expected ratio = 1e-07obtained abs = 1.15246e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000167321; expected ratio = 0.0001obtained abs = 0.0475733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.993060e+05 Mflops = 7.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.55734e-05; expected ratio = 1e-07obtained abs = 8.99863e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000130667; expected ratio = 0.0001obtained abs = 0.0371511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.18422e-05; expected ratio = 1e-07obtained abs = 7.11432e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103706; expected ratio = 0.0001obtained abs = 0.0294854; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.134e-05; expected ratio = 1e-07obtained abs = 5.67311e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.32871e-05; expected ratio = 0.0001obtained abs = 0.0236797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.993060e+05 Mflops = 11.98 -Solve time = 0.02 -Solve flops = 2.544200e+04 Mflops = 1.53 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.31865e-05; expected ratio = 1e-07obtained abs = 4.55422e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.7537e-05; expected ratio = 0.0001obtained abs = 0.0192016; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.993060e+05 Mflops = 7.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.67889e-05; expected ratio = 1e-07obtained abs = 3.67627e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.52125e-05; expected ratio = 0.0001obtained abs = 0.0156975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.17262e-05; expected ratio = 1e-07obtained abs = 2.98152e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.54473e-05; expected ratio = 0.0001obtained abs = 0.0129211; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.76912e-05; expected ratio = 1e-07obtained abs = 2.42779e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.76235e-05; expected ratio = 0.0001obtained abs = 0.0106967; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000671864 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.993060e+05 Mflops = 7.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.4455e-05; expected ratio = 1e-07obtained abs = 1.98369e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.12937e-05; expected ratio = 0.0001obtained abs = 0.00889709; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.993060e+05 Mflops = 11.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.18454e-05; expected ratio = 1e-07obtained abs = 1.62557e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.61295e-05; expected ratio = 0.0001obtained abs = 0.00742884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.73118e-06; expected ratio = 1e-07obtained abs = 1.33543e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.18862e-05; expected ratio = 0.0001obtained abs = 0.00622243; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.01121e-06; expected ratio = 1e-07obtained abs = 1.0994e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.8379e-05; expected ratio = 0.0001obtained abs = 0.00522531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.993060e+05 Mflops = 7.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.60708e-06; expected ratio = 1e-07obtained abs = 9.06705e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.54662e-05; expected ratio = 0.0001obtained abs = 0.00439715; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.44 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.44 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0126896; expected ratio = 1e-07obtained abs = 0.000173891; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0329314; expected ratio = 0.0001obtained abs = 9.1315; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.993060e+05 Mflops = 11.98 -Solve time = 0.02 -Solve flops = 2.544200e+04 Mflops = 1.53 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00195067; expected ratio = 1e-07obtained abs = 2.67322e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00402823; expected ratio = 0.0001obtained abs = 1.11905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000552177 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000538477; expected ratio = 1e-07obtained abs = 7.37937e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00105078; expected ratio = 0.0001obtained abs = 0.291835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000210392; expected ratio = 1e-07obtained abs = 2.88326e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000454859; expected ratio = 0.0001obtained abs = 0.126315; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000120463; expected ratio = 1e-07obtained abs = 1.65086e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000271584; expected ratio = 0.0001obtained abs = 0.075413; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000566959 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.50411e-05; expected ratio = 1e-07obtained abs = 1.16544e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000188577; expected ratio = 0.0001obtained abs = 0.0523609; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.42788e-05; expected ratio = 1e-07obtained abs = 8.80908e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000139144; expected ratio = 0.0001obtained abs = 0.0386337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.97544e-05; expected ratio = 1e-07obtained abs = 6.81861e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000105465; expected ratio = 0.0001obtained abs = 0.0292816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.998460e+05 Mflops = 23.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.89745e-05; expected ratio = 1e-07obtained abs = 5.34129e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.1253e-05; expected ratio = 0.0001obtained abs = 0.022559; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000564098 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.07796e-05; expected ratio = 1e-07obtained abs = 4.21822e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.34143e-05; expected ratio = 0.0001obtained abs = 0.017606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.44635e-05; expected ratio = 1e-07obtained abs = 3.35264e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.00597e-05; expected ratio = 0.0001obtained abs = 0.0138982; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.95461e-05; expected ratio = 1e-07obtained abs = 2.67872e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.99254e-05; expected ratio = 0.0001obtained abs = 0.0110845; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000544786 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.998460e+05 Mflops = 23.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.56856e-05; expected ratio = 1e-07obtained abs = 2.14965e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.21359e-05; expected ratio = 0.0001obtained abs = 0.00892181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.26332e-05; expected ratio = 1e-07obtained abs = 1.73135e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.60756e-05; expected ratio = 0.0001obtained abs = 0.00723928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.02054e-05; expected ratio = 1e-07obtained abs = 1.39862e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.13074e-05; expected ratio = 0.0001obtained abs = 0.00591549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.0147901 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.02 -Solve flops = 2.547200e+04 Mflops = 1.53 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.26441e-06; expected ratio = 1e-07obtained abs = 1.13261e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.75174e-05; expected ratio = 0.0001obtained abs = 0.00486328; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.70613e-06; expected ratio = 1e-07obtained abs = 9.19056e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.44776e-05; expected ratio = 0.0001obtained abs = 0.00401935; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.45 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.45 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000565052 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.993060e+05 Mflops = 11.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0082025; expected ratio = 1e-07obtained abs = 0.000112191; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0159629; expected ratio = 0.0001obtained abs = 4.46889; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00151493; expected ratio = 1e-07obtained abs = 2.07231e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00402233; expected ratio = 0.0001obtained abs = 1.12768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00046675; expected ratio = 1e-07obtained abs = 6.38481e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0010629; expected ratio = 0.0001obtained abs = 0.297926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000634909 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.02 -Solve flops = 2.547200e+04 Mflops = 1.53 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191016; expected ratio = 1e-07obtained abs = 2.61298e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000388673; expected ratio = 0.0001obtained abs = 0.108943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.998460e+05 Mflops = 12.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000103246; expected ratio = 1e-07obtained abs = 1.41234e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000191452; expected ratio = 0.0001obtained abs = 0.0536628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.91344e-05; expected ratio = 1e-07obtained abs = 9.45723e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000118122; expected ratio = 0.0001obtained abs = 0.0331089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.12856e-05; expected ratio = 1e-07obtained abs = 7.01564e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.39616e-05; expected ratio = 0.0001obtained abs = 0.0235337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000682116 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.02 -Solve flops = 2.547200e+04 Mflops = 1.53 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.95846e-05; expected ratio = 1e-07obtained abs = 5.41501e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.35015e-05; expected ratio = 0.0001obtained abs = 0.0177989; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.998460e+05 Mflops = 23.99 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.10445e-05; expected ratio = 1e-07obtained abs = 4.24677e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.92298e-05; expected ratio = 0.0001obtained abs = 0.0137986; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.12 -Factor flops = 3.998460e+05 Mflops = 3.43 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.45333e-05; expected ratio = 1e-07obtained abs = 3.35607e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.86028e-05; expected ratio = 0.0001obtained abs = 0.0108199; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.94742e-05; expected ratio = 1e-07obtained abs = 2.66401e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.04749e-05; expected ratio = 0.0001obtained abs = 0.00854174; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000594854 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.998460e+05 Mflops = 12.00 -Solve time = 0.02 -Solve flops = 2.547200e+04 Mflops = 1.53 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.5505e-05; expected ratio = 1e-07obtained abs = 2.12104e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.41767e-05; expected ratio = 0.0001obtained abs = 0.00677642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.23722e-05; expected ratio = 1e-07obtained abs = 1.69248e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.92567e-05; expected ratio = 0.0001obtained abs = 0.00539739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.88906e-06; expected ratio = 1e-07obtained abs = 1.3528e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.53902e-05; expected ratio = 0.0001obtained abs = 0.00431367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.91475e-06; expected ratio = 1e-07obtained abs = 1.08272e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.23373e-05; expected ratio = 0.0001obtained abs = 0.00345797; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000561953 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.998460e+05 Mflops = 8.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.34118e-06; expected ratio = 1e-07obtained abs = 8.67456e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.91727e-06; expected ratio = 0.0001obtained abs = 0.00277967; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.46 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.46 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.993060e+05 Mflops = 11.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0085174; expected ratio = 1e-07obtained abs = 0.000116154; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.015029; expected ratio = 0.0001obtained abs = 4.17751; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.955780e+05 Mflops = 7.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00137582; expected ratio = 1e-07obtained abs = 1.87649e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00391662; expected ratio = 0.0001obtained abs = 1.09113; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000419836; expected ratio = 1e-07obtained abs = 5.72616e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000947507; expected ratio = 0.0001obtained abs = 0.263926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000167841; expected ratio = 1e-07obtained abs = 2.28919e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00035265; expected ratio = 0.0001obtained abs = 0.0982279; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.955780e+05 Mflops = 7.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.76553e-05; expected ratio = 1e-07obtained abs = 1.19554e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000169525; expected ratio = 0.0001obtained abs = 0.047219; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.955780e+05 Mflops = 11.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.68515e-05; expected ratio = 1e-07obtained abs = 7.75408e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000101125; expected ratio = 0.0001obtained abs = 0.0281666; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.12281e-05; expected ratio = 1e-07obtained abs = 5.62319e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.97222e-05; expected ratio = 0.0001obtained abs = 0.0194195; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.13123e-05; expected ratio = 1e-07obtained abs = 4.27077e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.13692e-05; expected ratio = 0.0001obtained abs = 0.0143075; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.955780e+05 Mflops = 7.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.42415e-05; expected ratio = 1e-07obtained abs = 3.30636e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.88841e-05; expected ratio = 0.0001obtained abs = 0.0108301; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.955780e+05 Mflops = 11.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.89368e-05; expected ratio = 1e-07obtained abs = 2.58285e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.98046e-05; expected ratio = 0.0001obtained abs = 0.00830116; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.48665e-05; expected ratio = 1e-07obtained abs = 2.02769e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.30167e-05; expected ratio = 0.0001obtained abs = 0.00641056; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17079e-05; expected ratio = 1e-07obtained abs = 1.59688e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.78728e-05; expected ratio = 0.0001obtained abs = 0.00497787; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.07 -Factor flops = 3.955780e+05 Mflops = 5.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.24077e-06; expected ratio = 1e-07obtained abs = 1.26038e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.39411e-05; expected ratio = 0.0001obtained abs = 0.00388282; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.955780e+05 Mflops = 23.73 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.30557e-06; expected ratio = 1e-07obtained abs = 9.96434e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.09162e-05; expected ratio = 0.0001obtained abs = 0.00304034; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.47 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.47 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.07 -Factor flops = 3.951720e+05 Mflops = 5.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0112778; expected ratio = 1e-07obtained abs = 0.000153125; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0232987; expected ratio = 0.0001obtained abs = 6.54062; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.001753; expected ratio = 1e-07obtained abs = 2.38042e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00521818; expected ratio = 0.0001obtained abs = 1.47092; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000532988; expected ratio = 1e-07obtained abs = 7.23745e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000971287; expected ratio = 0.0001obtained abs = 0.2738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000204512; expected ratio = 1e-07obtained abs = 2.77707e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000381901; expected ratio = 0.0001obtained abs = 0.107657; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000564098 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.944580e+05 Mflops = 7.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.98335e-05; expected ratio = 1e-07obtained abs = 1.35565e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000181436; expected ratio = 0.0001obtained abs = 0.051145; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.0383e-05; expected ratio = 1e-07obtained abs = 8.19949e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103671; expected ratio = 0.0001obtained abs = 0.0292231; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.15837e-05; expected ratio = 1e-07obtained abs = 5.64672e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.79504e-05; expected ratio = 0.0001obtained abs = 0.0191537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.525000e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.04815e-05; expected ratio = 1e-07obtained abs = 4.13914e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.79465e-05; expected ratio = 0.0001obtained abs = 0.0135148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000573874 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.944580e+05 Mflops = 7.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.29974e-05; expected ratio = 1e-07obtained abs = 3.12287e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.50194e-05; expected ratio = 0.0001obtained abs = 0.00987086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.76033e-05; expected ratio = 1e-07obtained abs = 2.39039e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.60223e-05; expected ratio = 0.0001obtained abs = 0.00733479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.35851e-05; expected ratio = 1e-07obtained abs = 1.84476e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.95428e-05; expected ratio = 0.0001obtained abs = 0.0055084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.944580e+05 Mflops = 23.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.05393e-05; expected ratio = 1e-07obtained abs = 1.43115e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.47974e-05; expected ratio = 0.0001obtained abs = 0.00417082; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.944580e+05 Mflops = 7.89 -Solve time = 0.02 -Solve flops = 2.525000e+04 Mflops = 1.52 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.20664e-06; expected ratio = 1e-07obtained abs = 1.1144e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.12872e-05; expected ratio = 0.0001obtained abs = 0.00318143; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.4084e-06; expected ratio = 1e-07obtained abs = 8.70215e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.67208e-06; expected ratio = 0.0001obtained abs = 0.00244431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.48 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 142 - - Mesh vertices: 124 - Mesh triangles: 142 - Mesh edges: 230 - Mesh exterior boundary edges: 34 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 34 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.48 -matrix_partition : [9](0,28,56,84,112,140,168,196,227) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000566006 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.569950e+05 Mflops = 21.42 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.01507; expected ratio = 1e-07obtained abs = 0.00020335; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0364592; expected ratio = 0.0001obtained abs = 10.2346; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00253804; expected ratio = 1e-07obtained abs = 3.42523e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00590868; expected ratio = 0.0001obtained abs = 1.66633; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000843741; expected ratio = 1e-07obtained abs = 1.13866e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00150605; expected ratio = 0.0001obtained abs = 0.424615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.573610e+05 Mflops = 7.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000344726; expected ratio = 1e-07obtained abs = 4.65221e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000776286; expected ratio = 0.0001obtained abs = 0.21883; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.573610e+05 Mflops = 21.44 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00016796; expected ratio = 1e-07obtained abs = 2.26668e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000431693; expected ratio = 0.0001obtained abs = 0.121676; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.16105e-05; expected ratio = 1e-07obtained abs = 1.23632e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000251897; expected ratio = 0.0001obtained abs = 0.070993; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.37474e-05; expected ratio = 1e-07obtained abs = 7.25345e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0001547; expected ratio = 0.0001obtained abs = 0.0435966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.575170e+05 Mflops = 7.15 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.35261e-05; expected ratio = 1e-07obtained abs = 4.52451e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.98761e-05; expected ratio = 0.0001obtained abs = 0.0281452; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000561953 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.575170e+05 Mflops = 21.45 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.21595e-05; expected ratio = 1e-07obtained abs = 2.99053e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.72738e-05; expected ratio = 0.0001obtained abs = 0.0189572; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.54073e-05; expected ratio = 1e-07obtained abs = 2.07929e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.67742e-05; expected ratio = 0.0001obtained abs = 0.0131802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.1133e-05; expected ratio = 1e-07obtained abs = 1.50246e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.32458e-05; expected ratio = 0.0001obtained abs = 0.009368; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.575170e+05 Mflops = 7.15 -Solve time = 0.02 -Solve flops = 2.453600e+04 Mflops = 1.47 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.25575e-06; expected ratio = 1e-07obtained abs = 1.11416e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.39941e-05; expected ratio = 0.0001obtained abs = 0.00676097; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,142) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 227 -RHS size in solver: 227 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.575170e+05 Mflops = 21.45 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.22207e-06; expected ratio = 1e-07obtained abs = 8.397e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.75176e-05; expected ratio = 0.0001obtained abs = 0.00493599; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.49 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.49 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00059104 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.479540e+05 Mflops = 6.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0186341; expected ratio = 1e-07obtained abs = 0.0002489; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121936; expected ratio = 0.0001obtained abs = 33.852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00262058; expected ratio = 1e-07obtained abs = 3.50082e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00813558; expected ratio = 0.0001obtained abs = 2.27144; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000888166; expected ratio = 1e-07obtained abs = 1.18648e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00140557; expected ratio = 0.0001obtained abs = 0.392509; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00056982 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000368915; expected ratio = 1e-07obtained abs = 4.92822e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000623045; expected ratio = 0.0001obtained abs = 0.173992; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000585079 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.477200e+05 Mflops = 6.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000182502; expected ratio = 1e-07obtained abs = 2.43798e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000337019; expected ratio = 0.0001obtained abs = 0.0941161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000100619; expected ratio = 1e-07obtained abs = 1.34414e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00020286; expected ratio = 0.0001obtained abs = 0.0566503; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.87875e-05; expected ratio = 1e-07obtained abs = 7.85322e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000128593; expected ratio = 0.0001obtained abs = 0.0359103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.54856e-05; expected ratio = 1e-07obtained abs = 4.7404e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.42572e-05; expected ratio = 0.0001obtained abs = 0.0235293; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000586033 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.484340e+05 Mflops = 6.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.18893e-05; expected ratio = 1e-07obtained abs = 2.92412e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.71313e-05; expected ratio = 0.0001obtained abs = 0.0159542; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.37474e-05; expected ratio = 1e-07obtained abs = 1.83648e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.04143e-05; expected ratio = 0.0001obtained abs = 0.0112859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00061202 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.79667e-06; expected ratio = 1e-07obtained abs = 1.17512e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.00303e-05; expected ratio = 0.0001obtained abs = 0.00838606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.75919e-06; expected ratio = 1e-07obtained abs = 7.69352e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.34422e-05; expected ratio = 0.0001obtained abs = 0.00654631; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.5 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.5 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574827 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0206871; expected ratio = 1e-07obtained abs = 0.000272833; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.033779; expected ratio = 0.0001obtained abs = 9.51677; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.758050e+05 Mflops = 11.27 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00240289; expected ratio = 1e-07obtained abs = 3.16993e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00730994; expected ratio = 0.0001obtained abs = 2.07073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.758050e+05 Mflops = 7.52 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000744675; expected ratio = 1e-07obtained abs = 9.82365e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00124277; expected ratio = 0.0001obtained abs = 0.352064; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000619888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000288496; expected ratio = 1e-07obtained abs = 3.80578e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000538074; expected ratio = 0.0001obtained abs = 0.152437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000141971; expected ratio = 1e-07obtained abs = 1.87284e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000303865; expected ratio = 0.0001obtained abs = 0.086086; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.756490e+05 Mflops = 11.27 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.27393e-05; expected ratio = 1e-07obtained abs = 1.09148e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000199089; expected ratio = 0.0001obtained abs = 0.0564026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.756490e+05 Mflops = 7.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.24722e-05; expected ratio = 1e-07obtained abs = 6.92199e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000142078; expected ratio = 0.0001obtained abs = 0.0402511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.47926e-05; expected ratio = 1e-07obtained abs = 4.58975e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107837; expected ratio = 0.0001obtained abs = 0.0305505; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.38288e-05; expected ratio = 1e-07obtained abs = 3.14344e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.59474e-05; expected ratio = 0.0001obtained abs = 0.0243491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000694036 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.756490e+05 Mflops = 7.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.68373e-05; expected ratio = 1e-07obtained abs = 2.22114e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.1045e-05; expected ratio = 0.0001obtained abs = 0.0201272; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000762939 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.756490e+05 Mflops = 11.27 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.23028e-05; expected ratio = 1e-07obtained abs = 1.62295e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.02079e-05; expected ratio = 0.0001obtained abs = 0.017057; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570774 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.31325e-06; expected ratio = 1e-07obtained abs = 1.22858e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.18414e-05; expected ratio = 0.0001obtained abs = 0.0146868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.29762e-06; expected ratio = 1e-07obtained abs = 9.62685e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.50727e-05; expected ratio = 0.0001obtained abs = 0.0127692; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -line49 -Estimating delta time -0.51 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.51 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0172779; expected ratio = 1e-07obtained abs = 0.000224894; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0288706; expected ratio = 0.0001obtained abs = 7.97484; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000654936 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.973280e+05 Mflops = 5.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00197615; expected ratio = 1e-07obtained abs = 2.57295e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00563449; expected ratio = 0.0001obtained abs = 1.56308; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000639832; expected ratio = 1e-07obtained abs = 8.33038e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00106825; expected ratio = 0.0001obtained abs = 0.296285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000272467; expected ratio = 1e-07obtained abs = 3.54738e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000545709; expected ratio = 0.0001obtained abs = 0.151338; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000146253; expected ratio = 1e-07obtained abs = 1.90412e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000323974; expected ratio = 0.0001obtained abs = 0.0898383; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.973280e+05 Mflops = 5.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.03424e-05; expected ratio = 1e-07obtained abs = 1.1762e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000204691; expected ratio = 0.0001obtained abs = 0.0567583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000577927 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.00653e-05; expected ratio = 1e-07obtained abs = 7.82009e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000135562; expected ratio = 0.0001obtained abs = 0.0375887; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.16966e-05; expected ratio = 1e-07obtained abs = 5.42859e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.39579e-05; expected ratio = 0.0001obtained abs = 0.0260523; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000605106 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.98106e-05; expected ratio = 1e-07obtained abs = 3.88111e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.79119e-05; expected ratio = 0.0001obtained abs = 0.0188302; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.973280e+05 Mflops = 5.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.17801e-05; expected ratio = 1e-07obtained abs = 2.8356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.0866e-05; expected ratio = 0.0001obtained abs = 0.0141038; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.973280e+05 Mflops = 17.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.61736e-05; expected ratio = 1e-07obtained abs = 2.10568e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.92016e-05; expected ratio = 0.0001obtained abs = 0.0108695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.21561e-05; expected ratio = 1e-07obtained abs = 1.58263e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.08972e-05; expected ratio = 0.0001obtained abs = 0.00856695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.21771e-06; expected ratio = 1e-07obtained abs = 1.20007e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.47904e-05; expected ratio = 0.0001obtained abs = 0.0068737; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000572205 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.973280e+05 Mflops = 5.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.03474e-06; expected ratio = 1e-07obtained abs = 9.15865e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.0183e-05; expected ratio = 0.0001obtained abs = 0.0055962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.52 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.52 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0171908; expected ratio = 1e-07obtained abs = 0.00022064; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115257; expected ratio = 0.0001obtained abs = 3.20506; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570774 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.973280e+05 Mflops = 5.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00187745; expected ratio = 1e-07obtained abs = 2.41035e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0053712; expected ratio = 0.0001obtained abs = 1.49898; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.973280e+05 Mflops = 17.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000634028; expected ratio = 1e-07obtained abs = 8.13972e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00120126; expected ratio = 0.0001obtained abs = 0.335114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000573158 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000283493; expected ratio = 1e-07obtained abs = 3.63947e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000608542; expected ratio = 0.0001obtained abs = 0.169729; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000156801; expected ratio = 1e-07obtained abs = 2.01299e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000366894; expected ratio = 0.0001obtained abs = 0.102316; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.02 -Solve flops = 2.243200e+04 Mflops = 1.35 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.85594e-05; expected ratio = 1e-07obtained abs = 1.26529e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000236278; expected ratio = 0.0001obtained abs = 0.0658844; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000595093 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.63915e-05; expected ratio = 1e-07obtained abs = 8.52318e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00015718; expected ratio = 0.0001obtained abs = 0.0438257; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00126719 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.65827e-05; expected ratio = 1e-07obtained abs = 5.98017e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000106916; expected ratio = 0.0001obtained abs = 0.0298095; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.35969e-05; expected ratio = 1e-07obtained abs = 4.31308e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.41261e-05; expected ratio = 0.0001obtained abs = 0.0206667; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000710964 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.02 -Solve flops = 2.243200e+04 Mflops = 1.35 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.47408e-05; expected ratio = 1e-07obtained abs = 3.17614e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.23598e-05; expected ratio = 0.0001obtained abs = 0.0145979; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.973280e+05 Mflops = 17.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.85263e-05; expected ratio = 1e-07obtained abs = 2.37835e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.76997e-05; expected ratio = 0.0001obtained abs = 0.0105105; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570774 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.40643e-05; expected ratio = 1e-07obtained abs = 1.80553e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.76805e-05; expected ratio = 0.0001obtained abs = 0.00771714; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.07972e-05; expected ratio = 1e-07obtained abs = 1.38611e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.0722e-05; expected ratio = 0.0001obtained abs = 0.00577712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000580072 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973280e+05 Mflops = 8.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.36428e-06; expected ratio = 1e-07obtained abs = 1.07378e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.5802e-05; expected ratio = 0.0001obtained abs = 0.00440544; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.973280e+05 Mflops = 5.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.52637e-06; expected ratio = 1e-07obtained abs = 8.3783e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.22559e-05; expected ratio = 0.0001obtained abs = 0.00341682; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.53 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.53 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000703812 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.968160e+05 Mflops = 5.94 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.017721; expected ratio = 1e-07obtained abs = 0.000224053; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0170836; expected ratio = 0.0001obtained abs = 4.69224; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000813007 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.968160e+05 Mflops = 17.81 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00194897; expected ratio = 1e-07obtained abs = 2.46483e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00508637; expected ratio = 0.0001obtained abs = 1.40161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000629934; expected ratio = 1e-07obtained abs = 7.96643e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114276; expected ratio = 0.0001obtained abs = 0.314811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000238737; expected ratio = 1e-07obtained abs = 3.01915e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00045804; expected ratio = 0.0001obtained abs = 0.126165; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568151 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000107648; expected ratio = 1e-07obtained abs = 1.36134e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000243253; expected ratio = 0.0001obtained abs = 0.0669964; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.91365e-05; expected ratio = 1e-07obtained abs = 7.47852e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000152078; expected ratio = 0.0001obtained abs = 0.0418822; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.81599e-05; expected ratio = 1e-07obtained abs = 4.82576e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103201; expected ratio = 0.0001obtained abs = 0.0284203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568151 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.71388e-05; expected ratio = 1e-07obtained abs = 3.432e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.32709e-05; expected ratio = 0.0001obtained abs = 0.0201772; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.02 -Solve flops = 2.230200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.0322e-05; expected ratio = 1e-07obtained abs = 2.56994e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.38141e-05; expected ratio = 0.0001obtained abs = 0.0148189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.56474e-05; expected ratio = 1e-07obtained abs = 1.97879e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.07646e-05; expected ratio = 0.0001obtained abs = 0.0112253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570774 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.22475e-05; expected ratio = 1e-07obtained abs = 1.54883e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.17825e-05; expected ratio = 0.0001obtained abs = 0.00875181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.68849e-06; expected ratio = 1e-07obtained abs = 1.22521e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.54185e-05; expected ratio = 0.0001obtained abs = 0.00699934; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.72098e-06; expected ratio = 1e-07obtained abs = 9.76399e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.07604e-05; expected ratio = 0.0001obtained abs = 0.00571664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.54 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.54 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0186288; expected ratio = 1e-07obtained abs = 0.000231735; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00933174; expected ratio = 0.0001obtained abs = 2.56623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00197486; expected ratio = 1e-07obtained abs = 2.45739e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00506811; expected ratio = 0.0001obtained abs = 1.39828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000657132; expected ratio = 1e-07obtained abs = 8.17673e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00110409; expected ratio = 0.0001obtained abs = 0.304566; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000617981 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000248841; expected ratio = 1e-07obtained abs = 3.09632e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000390629; expected ratio = 0.0001obtained abs = 0.10775; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000104881; expected ratio = 1e-07obtained abs = 1.30502e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000179914; expected ratio = 0.0001obtained abs = 0.0496248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568151 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.96035e-05; expected ratio = 1e-07obtained abs = 6.1721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104565; expected ratio = 0.0001obtained abs = 0.0288403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568151 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.66312e-05; expected ratio = 1e-07obtained abs = 3.31368e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.04973e-05; expected ratio = 0.0001obtained abs = 0.0194435; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00183797 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.63e-05; expected ratio = 1e-07obtained abs = 2.02818e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.10864e-05; expected ratio = 0.0001obtained abs = 0.0140896; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000566959 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.11651e-05; expected ratio = 1e-07obtained abs = 1.38925e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.86673e-05; expected ratio = 0.0001obtained abs = 0.0106643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000567913 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.26447e-06; expected ratio = 1e-07obtained abs = 1.02833e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.02998e-05; expected ratio = 0.0001obtained abs = 0.00835645; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000584126 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.02 -Solve flops = 2.230200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.40314e-06; expected ratio = 1e-07obtained abs = 7.9673e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.44495e-05; expected ratio = 0.0001obtained abs = 0.00674294; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.55 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.55 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.019535; expected ratio = 1e-07obtained abs = 0.000238822; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0133622; expected ratio = 0.0001obtained abs = 3.6461; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000567913 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00185461; expected ratio = 1e-07obtained abs = 2.26803e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00563334; expected ratio = 0.0001obtained abs = 1.54189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000621524; expected ratio = 1e-07obtained abs = 7.60049e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00111914; expected ratio = 0.0001obtained abs = 0.30625; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000567913 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00024144; expected ratio = 1e-07obtained abs = 2.9525e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00041727; expected ratio = 0.0001obtained abs = 0.114175; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000564814 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.230200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000104879; expected ratio = 1e-07obtained abs = 1.28252e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000203159; expected ratio = 0.0001obtained abs = 0.0555846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000593901 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.0362e-05; expected ratio = 1e-07obtained abs = 6.15859e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000121629; expected ratio = 0.0001obtained abs = 0.0332757; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000592947 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.64451e-05; expected ratio = 1e-07obtained abs = 3.23387e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.10341e-05; expected ratio = 0.0001obtained abs = 0.0221687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.51023e-05; expected ratio = 1e-07obtained abs = 1.84681e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.66059e-05; expected ratio = 0.0001obtained abs = 0.0154853; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.34932e-06; expected ratio = 1e-07obtained abs = 1.14329e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.08166e-05; expected ratio = 0.0001obtained abs = 0.0111657; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000566959 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.23585e-06; expected ratio = 1e-07obtained abs = 7.62557e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.03977e-05; expected ratio = 0.0001obtained abs = 0.00831541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.56 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.56 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0205676; expected ratio = 1e-07obtained abs = 0.000246814; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00850706; expected ratio = 0.0001obtained abs = 2.31899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000640154 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00181284; expected ratio = 1e-07obtained abs = 2.17611e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00586121; expected ratio = 0.0001obtained abs = 1.6025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000575781 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000616098; expected ratio = 1e-07obtained abs = 7.3954e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114223; expected ratio = 0.0001obtained abs = 0.312222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000566959 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000245098; expected ratio = 1e-07obtained abs = 2.94204e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000442558; expected ratio = 0.0001obtained abs = 0.120957; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00056982 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000110412; expected ratio = 1e-07obtained abs = 1.32533e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00021999; expected ratio = 0.0001obtained abs = 0.0601212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000638962 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.02 -Solve flops = 2.230200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.56643e-05; expected ratio = 1e-07obtained abs = 6.68166e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131671; expected ratio = 0.0001obtained abs = 0.0359822; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000579834 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.08605e-05; expected ratio = 1e-07obtained abs = 3.70433e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.67522e-05; expected ratio = 0.0001obtained abs = 0.0237059; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.84892e-05; expected ratio = 1e-07obtained abs = 2.21935e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.96111e-05; expected ratio = 0.0001obtained abs = 0.0162888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17762e-05; expected ratio = 1e-07obtained abs = 1.41356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.20196e-05; expected ratio = 0.0001obtained abs = 0.0114816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.86084e-06; expected ratio = 1e-07obtained abs = 9.43573e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.03701e-05; expected ratio = 0.0001obtained abs = 0.00829832; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.57 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.57 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0216971; expected ratio = 1e-07obtained abs = 0.00025525; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.01129; expected ratio = 0.0001obtained abs = 3.05909; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000566959 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179618; expected ratio = 1e-07obtained abs = 2.11373e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00614217; expected ratio = 0.0001obtained abs = 1.66904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000622848; expected ratio = 1e-07obtained abs = 7.32944e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114498; expected ratio = 0.0001obtained abs = 0.311053; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570774 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000254159; expected ratio = 1e-07obtained abs = 2.99082e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000455136; expected ratio = 0.0001obtained abs = 0.123632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000567198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00011814; expected ratio = 1e-07obtained abs = 1.39021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000232356; expected ratio = 0.0001obtained abs = 0.0631103; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000566959 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.16357e-05; expected ratio = 1e-07obtained abs = 7.25297e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000141746; expected ratio = 0.0001obtained abs = 0.0384971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.52883e-05; expected ratio = 1e-07obtained abs = 4.15254e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.44204e-05; expected ratio = 0.0001obtained abs = 0.0256425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00056982 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.16983e-05; expected ratio = 1e-07obtained abs = 2.55334e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.52594e-05; expected ratio = 0.0001obtained abs = 0.0177223; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.40674e-05; expected ratio = 1e-07obtained abs = 1.65538e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.60593e-05; expected ratio = 0.0001obtained abs = 0.0125079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000566959 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.47702e-06; expected ratio = 1e-07obtained abs = 1.11521e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.31522e-05; expected ratio = 0.0001obtained abs = 0.00900267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000585079 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.56546e-06; expected ratio = 1e-07obtained abs = 7.72588e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.44168e-05; expected ratio = 0.0001obtained abs = 0.00663044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.58 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.58 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000573158 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0228948; expected ratio = 1e-07obtained abs = 0.000263698; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00892099; expected ratio = 0.0001obtained abs = 2.41132; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.956840e+05 Mflops = 8.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179031; expected ratio = 1e-07obtained abs = 2.06268e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00643953; expected ratio = 0.0001obtained abs = 1.74541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000567913 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000634399; expected ratio = 1e-07obtained abs = 7.30896e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00115807; expected ratio = 0.0001obtained abs = 0.313809; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000265041; expected ratio = 1e-07obtained abs = 3.05354e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00047347; expected ratio = 0.0001obtained abs = 0.128283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000566006 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000126376; expected ratio = 1e-07obtained abs = 1.45597e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000246681; expected ratio = 0.0001obtained abs = 0.0668296; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058794 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.956840e+05 Mflops = 5.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.76212e-05; expected ratio = 1e-07obtained abs = 7.79061e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000152072; expected ratio = 0.0001obtained abs = 0.0411956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.96138e-05; expected ratio = 1e-07obtained abs = 4.56388e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000101936; expected ratio = 0.0001obtained abs = 0.0276125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000566959 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.48382e-05; expected ratio = 1e-07obtained abs = 2.8616e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.08432e-05; expected ratio = 0.0001obtained abs = 0.0191892; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.63633e-05; expected ratio = 1e-07obtained abs = 1.88521e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.02372e-05; expected ratio = 0.0001obtained abs = 0.0136073; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00068903 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.956840e+05 Mflops = 8.87 -Solve time = 0.02 -Solve flops = 2.236600e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.11668e-05; expected ratio = 1e-07obtained abs = 1.28652e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.62557e-05; expected ratio = 0.0001obtained abs = 0.00982008; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000583172 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.956840e+05 Mflops = 17.74 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.81454e-06; expected ratio = 1e-07obtained abs = 9.00308e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.66802e-05; expected ratio = 0.0001obtained abs = 0.0072264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.59 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.59 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000591993 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.973700e+05 Mflops = 8.92 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0241659; expected ratio = 1e-07obtained abs = 0.000272137; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0103399; expected ratio = 0.0001obtained abs = 2.78127; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057888 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179002; expected ratio = 1e-07obtained abs = 2.01637e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00678411; expected ratio = 0.0001obtained abs = 1.82971; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000572205 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000648682; expected ratio = 1e-07obtained abs = 7.30693e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00116932; expected ratio = 0.0001obtained abs = 0.31529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000277145; expected ratio = 1e-07obtained abs = 3.12182e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000488005; expected ratio = 0.0001obtained abs = 0.131567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000680923 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0001351; expected ratio = 1e-07obtained abs = 1.52179e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00025761; expected ratio = 0.0001obtained abs = 0.0694451; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000771046 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.37046e-05; expected ratio = 1e-07obtained abs = 8.30221e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00015994; expected ratio = 0.0001obtained abs = 0.0431124; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.38473e-05; expected ratio = 1e-07obtained abs = 4.93902e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107812; expected ratio = 0.0001obtained abs = 0.0290593; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.78186e-05; expected ratio = 1e-07obtained abs = 3.13353e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.53748e-05; expected ratio = 0.0001obtained abs = 0.0203155; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.02 -Solve flops = 2.240200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.84995e-05; expected ratio = 1e-07obtained abs = 2.08381e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.37726e-05; expected ratio = 0.0001obtained abs = 0.0144927; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000583172 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.963800e+05 Mflops = 17.78 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.27271e-05; expected ratio = 1e-07obtained abs = 1.4336e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.90014e-05; expected ratio = 0.0001obtained abs = 0.0105114; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000573158 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.97284e-06; expected ratio = 1e-07obtained abs = 1.01071e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.8781e-05; expected ratio = 0.0001obtained abs = 0.00775673; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000573158 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.44129e-06; expected ratio = 1e-07obtained abs = 7.25556e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.16512e-05; expected ratio = 0.0001obtained abs = 0.0058351; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.6 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.6 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0255106; expected ratio = 1e-07obtained abs = 0.00028048; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00936151; expected ratio = 0.0001obtained abs = 2.51023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00179407; expected ratio = 1e-07obtained abs = 1.97306e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00714131; expected ratio = 0.0001obtained abs = 1.91986; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.963800e+05 Mflops = 5.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000665184; expected ratio = 1e-07obtained abs = 7.31534e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00118051; expected ratio = 0.0001obtained abs = 0.317286; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000290492; expected ratio = 1e-07obtained abs = 3.19465e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000502944; expected ratio = 0.0001obtained abs = 0.135159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000144652; expected ratio = 1e-07obtained abs = 1.59079e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000268864; expected ratio = 0.0001obtained abs = 0.0722457; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.03863e-05; expected ratio = 1e-07obtained abs = 8.84036e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000168076; expected ratio = 0.0001obtained abs = 0.0451597; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.85278e-05; expected ratio = 1e-07obtained abs = 5.33677e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113974; expected ratio = 0.0001obtained abs = 0.0306213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.963800e+05 Mflops = 8.89 -Solve time = 0.02 -Solve flops = 2.240200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.11416e-05; expected ratio = 1e-07obtained abs = 3.42475e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.02353e-05; expected ratio = 0.0001obtained abs = 0.0215558; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.09056e-05; expected ratio = 1e-07obtained abs = 2.29906e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.76707e-05; expected ratio = 0.0001obtained abs = 0.0154931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.45062e-05; expected ratio = 1e-07obtained abs = 1.59529e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.21245e-05; expected ratio = 0.0001obtained abs = 0.0113164; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000568867 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.03131e-05; expected ratio = 1e-07obtained abs = 1.13417e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.12554e-05; expected ratio = 0.0001obtained abs = 0.00839637; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000590086 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.963800e+05 Mflops = 5.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.4659e-06; expected ratio = 1e-07obtained abs = 8.2105e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.35786e-05; expected ratio = 0.0001obtained abs = 0.00633403; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.61 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.61 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.956840e+05 Mflops = 17.74 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0269318; expected ratio = 1e-07obtained abs = 0.000288667; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0100665; expected ratio = 0.0001obtained abs = 2.68789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000620127 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00180143; expected ratio = 1e-07obtained abs = 1.93133e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00753159; expected ratio = 0.0001obtained abs = 2.0161; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000573158 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000683372; expected ratio = 1e-07obtained abs = 7.32637e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00119148; expected ratio = 0.0001obtained abs = 0.318862; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000304808; expected ratio = 1e-07obtained abs = 3.2678e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000517185; expected ratio = 0.0001obtained abs = 0.13839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000154916; expected ratio = 1e-07obtained abs = 1.66083e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000279391; expected ratio = 0.0001obtained abs = 0.0747526; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000586987 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.76166e-05; expected ratio = 1e-07obtained abs = 9.39322e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00017561; expected ratio = 0.0001obtained abs = 0.0469816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000573158 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.36162e-05; expected ratio = 1e-07obtained abs = 5.74809e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000119708; expected ratio = 0.0001obtained abs = 0.0320238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000572205 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.4756e-05; expected ratio = 1e-07obtained abs = 3.72612e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.48328e-05; expected ratio = 0.0001obtained abs = 0.0226931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000567913 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.35158e-05; expected ratio = 1e-07obtained abs = 2.52109e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.1441e-05; expected ratio = 0.0001obtained abs = 0.0164352; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000698805 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.02 -Solve flops = 2.230200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.64291e-05; expected ratio = 1e-07obtained abs = 1.76134e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.52219e-05; expected ratio = 0.0001obtained abs = 0.0120963; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00058198 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17576e-05; expected ratio = 1e-07obtained abs = 1.26051e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.37761e-05; expected ratio = 0.0001obtained abs = 0.00903454; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.56928e-06; expected ratio = 1e-07obtained abs = 9.18697e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.55994e-05; expected ratio = 0.0001obtained abs = 0.00684732; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.62 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.62 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000620127 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0284349; expected ratio = 1e-07obtained abs = 0.000296658; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00975753; expected ratio = 0.0001obtained abs = 2.5966; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00181212; expected ratio = 1e-07obtained abs = 1.89096e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00794147; expected ratio = 0.0001obtained abs = 2.11848; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000703178; expected ratio = 1e-07obtained abs = 7.3376e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00120305; expected ratio = 0.0001obtained abs = 0.320847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000657797 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000320173; expected ratio = 1e-07obtained abs = 3.34096e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000532512; expected ratio = 0.0001obtained abs = 0.142; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00079298 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000166088; expected ratio = 1e-07obtained abs = 1.7331e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000290911; expected ratio = 0.0001obtained abs = 0.0775663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.56613e-05; expected ratio = 1e-07obtained abs = 9.98209e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000183932; expected ratio = 0.0001obtained abs = 0.0490381; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.9399e-05; expected ratio = 1e-07obtained abs = 6.19818e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00012608; expected ratio = 0.0001obtained abs = 0.033612; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.89326e-05; expected ratio = 1e-07obtained abs = 4.06255e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.9981e-05; expected ratio = 0.0001obtained abs = 0.0239872; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.940200e+05 Mflops = 17.64 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.65659e-05; expected ratio = 1e-07obtained abs = 2.7721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.57082e-05; expected ratio = 0.0001obtained abs = 0.0175159; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000714064 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.86902e-05; expected ratio = 1e-07obtained abs = 1.95029e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.87756e-05; expected ratio = 0.0001obtained abs = 0.0130018; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.3461e-05; expected ratio = 1e-07obtained abs = 1.40464e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.67167e-05; expected ratio = 0.0001obtained abs = 0.00978716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.8717e-06; expected ratio = 1e-07obtained abs = 1.03009e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.80042e-05; expected ratio = 0.0001obtained abs = 0.00746465; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000595093 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.940200e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.34256e-06; expected ratio = 1e-07obtained abs = 7.66184e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.16335e-05; expected ratio = 0.0001obtained abs = 0.00576647; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.63 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.63 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.940200e+05 Mflops = 5.88 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0300249; expected ratio = 1e-07obtained abs = 0.0003044; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010192; expected ratio = 0.0001obtained abs = 2.70181; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00057292 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.956660e+05 Mflops = 17.74 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00182673; expected ratio = 1e-07obtained abs = 1.85228e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00838346; expected ratio = 0.0001obtained abs = 2.22765; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000724745; expected ratio = 1e-07obtained abs = 7.34873e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0012161; expected ratio = 0.0001obtained abs = 0.323065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000598907 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00033668; expected ratio = 1e-07obtained abs = 3.41384e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000548978; expected ratio = 0.0001obtained abs = 0.145821; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000573874 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.956660e+05 Mflops = 8.87 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000178258; expected ratio = 1e-07obtained abs = 1.80748e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000303281; expected ratio = 0.0001obtained abs = 0.0805496; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.956660e+05 Mflops = 5.91 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000104626; expected ratio = 1e-07obtained abs = 1.06087e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000192885; expected ratio = 0.0001obtained abs = 0.0512248; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.59887e-05; expected ratio = 1e-07obtained abs = 6.69103e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000132946; expected ratio = 0.0001obtained abs = 0.0353044; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000572205 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.37772e-05; expected ratio = 1e-07obtained abs = 4.43886e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.55402e-05; expected ratio = 0.0001obtained abs = 0.0253699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.956660e+05 Mflops = 17.74 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.01459e-05; expected ratio = 1e-07obtained abs = 3.05669e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.03306e-05; expected ratio = 0.0001obtained abs = 0.018675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.00059104 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.956660e+05 Mflops = 8.87 -Solve time = 0.02 -Solve flops = 2.236600e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.13605e-05; expected ratio = 1e-07obtained abs = 2.16589e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.26408e-05; expected ratio = 0.0001obtained abs = 0.0139774; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000573158 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.54759e-05; expected ratio = 1e-07obtained abs = 1.5692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.99299e-05; expected ratio = 0.0001obtained abs = 0.0106021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.14099e-05; expected ratio = 1e-07obtained abs = 1.15692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.06455e-05; expected ratio = 0.0001obtained abs = 0.00813681; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.52929e-06; expected ratio = 1e-07obtained abs = 8.64842e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.37754e-05; expected ratio = 0.0001obtained abs = 0.00631261; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.64 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 143 - - Mesh vertices: 124 - Mesh triangles: 143 - Mesh edges: 232 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.64 -matrix_partition : [9](0,28,56,84,112,140,168,196,228) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0317099; expected ratio = 1e-07obtained abs = 0.000311863; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102283; expected ratio = 0.0001obtained abs = 2.70222; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000651121 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.229600e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00184546; expected ratio = 1e-07obtained abs = 1.81515e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00884789; expected ratio = 0.0001obtained abs = 2.3429; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000593901 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.938460e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000747508; expected ratio = 1e-07obtained abs = 7.35225e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00122892; expected ratio = 0.0001obtained abs = 0.325339; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000353791; expected ratio = 1e-07obtained abs = 3.47977e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000565605; expected ratio = 0.0001obtained abs = 0.149716; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000190984; expected ratio = 1e-07obtained abs = 1.87844e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000315902; expected ratio = 0.0001obtained abs = 0.083611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000648022 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000114199; expected ratio = 1e-07obtained abs = 1.12322e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00020203; expected ratio = 0.0001obtained abs = 0.0534676; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000702143 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.938460e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.31878e-05; expected ratio = 1e-07obtained abs = 7.19848e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000139956; expected ratio = 0.0001obtained abs = 0.0370373; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.91749e-05; expected ratio = 1e-07obtained abs = 4.83665e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000101233; expected ratio = 0.0001obtained abs = 0.0267885; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000570059 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.41936e-05; expected ratio = 1e-07obtained abs = 3.36315e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50993e-05; expected ratio = 0.0001obtained abs = 0.0198721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.4409e-05; expected ratio = 1e-07obtained abs = 2.40078e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.66715e-05; expected ratio = 0.0001obtained abs = 0.0149955; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.938460e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.77884e-05; expected ratio = 1e-07obtained abs = 1.7496e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.33262e-05; expected ratio = 0.0001obtained abs = 0.011464; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000574112 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.938460e+05 Mflops = 8.82 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.31793e-05; expected ratio = 1e-07obtained abs = 1.29627e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.34818e-05; expected ratio = 0.0001obtained abs = 0.00885904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,17,34,51,68,85,102,119,143) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 228 -RHS size in solver: 228 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.89488e-06; expected ratio = 1e-07obtained abs = 9.73223e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.61169e-05; expected ratio = 0.0001obtained abs = 0.00691025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.65 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.65 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000765085 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0368365; expected ratio = 1e-07obtained abs = 0.000349849; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.106224; expected ratio = 0.0001obtained abs = 27.8466; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00171273; expected ratio = 1e-07obtained abs = 1.62632e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010422; expected ratio = 0.0001obtained abs = 2.73931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000712095; expected ratio = 1e-07obtained abs = 6.76157e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00111645; expected ratio = 0.0001obtained abs = 0.293425; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.944320e+05 Mflops = 5.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000339661; expected ratio = 1e-07obtained abs = 3.22517e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000538605; expected ratio = 0.0001obtained abs = 0.141541; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000505209 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.944320e+05 Mflops = 8.83 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000184116; expected ratio = 1e-07obtained abs = 1.74822e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000301175; expected ratio = 0.0001obtained abs = 0.0791393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000110531; expected ratio = 1e-07obtained abs = 1.04952e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000190973; expected ratio = 0.0001obtained abs = 0.0501779; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.1107e-05; expected ratio = 1e-07obtained abs = 6.75177e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131111; expected ratio = 0.0001obtained abs = 0.0344471; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.78845e-05; expected ratio = 1e-07obtained abs = 4.54674e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.41789e-05; expected ratio = 0.0001obtained abs = 0.0247428; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000488997 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.944320e+05 Mflops = 5.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.3298e-05; expected ratio = 1e-07obtained abs = 3.16172e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.95219e-05; expected ratio = 0.0001obtained abs = 0.0182642; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.00047493 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.37207e-05; expected ratio = 1e-07obtained abs = 2.25233e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.22773e-05; expected ratio = 0.0001obtained abs = 0.0137335; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.72223e-05; expected ratio = 1e-07obtained abs = 1.6353e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.98552e-05; expected ratio = 0.0001obtained abs = 0.01047; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.26975e-05; expected ratio = 1e-07obtained abs = 1.20565e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.07182e-05; expected ratio = 0.0001obtained abs = 0.00806956; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000586987 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.944320e+05 Mflops = 8.83 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.47935e-06; expected ratio = 1e-07obtained abs = 9.00084e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.38898e-05; expected ratio = 0.0001obtained abs = 0.00627569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.66 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.66 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.044812; expected ratio = 1e-07obtained abs = 0.00040843; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0335469; expected ratio = 0.0001obtained abs = 8.97093; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.945100e+05 Mflops = 8.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00282807; expected ratio = 1e-07obtained abs = 2.57653e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0114858; expected ratio = 0.0001obtained abs = 3.08428; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.945100e+05 Mflops = 17.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00115868; expected ratio = 1e-07obtained abs = 1.05559e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00153266; expected ratio = 0.0001obtained abs = 0.411569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000529505; expected ratio = 1e-07obtained abs = 4.82397e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000771195; expected ratio = 0.0001obtained abs = 0.207066; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000278296; expected ratio = 1e-07obtained abs = 2.53539e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000452487; expected ratio = 0.0001obtained abs = 0.121477; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.945100e+05 Mflops = 8.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000172751; expected ratio = 1e-07obtained abs = 1.57384e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000302325; expected ratio = 0.0001obtained abs = 0.0811547; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.945100e+05 Mflops = 5.89 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000121276; expected ratio = 1e-07obtained abs = 1.10489e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000220206; expected ratio = 0.0001obtained abs = 0.0591057; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.07218e-05; expected ratio = 1e-07obtained abs = 8.26527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000168273; expected ratio = 0.0001obtained abs = 0.0451628; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.98614e-05; expected ratio = 1e-07obtained abs = 6.3648e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131893; expected ratio = 0.0001obtained abs = 0.0353964; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.45667e-05; expected ratio = 1e-07obtained abs = 4.97138e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0001048; expected ratio = 0.0001obtained abs = 0.0281242; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.945100e+05 Mflops = 8.84 -Solve time = 0.02 -Solve flops = 2.239600e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.29693e-05; expected ratio = 1e-07obtained abs = 3.91479e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.39155e-05; expected ratio = 0.0001obtained abs = 0.0225187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000478029 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.945100e+05 Mflops = 17.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.40214e-05; expected ratio = 1e-07obtained abs = 3.09959e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.75005e-05; expected ratio = 0.0001obtained abs = 0.0181131; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.70459e-05; expected ratio = 1e-07obtained abs = 2.46407e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.44549e-05; expected ratio = 0.0001obtained abs = 0.0146121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.15691e-05; expected ratio = 1e-07obtained abs = 1.9651e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.40192e-05; expected ratio = 0.0001obtained abs = 0.0118116; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.945100e+05 Mflops = 8.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.72463e-05; expected ratio = 1e-07obtained abs = 1.57126e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.56379e-05; expected ratio = 0.0001obtained abs = 0.00956253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455856 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.945100e+05 Mflops = 8.84 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.38199e-05; expected ratio = 1e-07obtained abs = 1.2591e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.8889e-05; expected ratio = 0.0001obtained abs = 0.00775153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.1095e-05; expected ratio = 1e-07obtained abs = 1.01084e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.34445e-05; expected ratio = 0.0001obtained abs = 0.0062906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.92176e-06; expected ratio = 1e-07obtained abs = 8.12839e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.90462e-05; expected ratio = 0.0001obtained abs = 0.00511042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.67 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.67 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0460379; expected ratio = 1e-07obtained abs = 0.000401375; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0324239; expected ratio = 0.0001obtained abs = 8.47261; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00263581; expected ratio = 1e-07obtained abs = 2.29714e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119448; expected ratio = 0.0001obtained abs = 3.13065; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000503063 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.037290e+05 Mflops = 9.11 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0012379; expected ratio = 1e-07obtained abs = 1.07884e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00140836; expected ratio = 0.0001obtained abs = 0.36899; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000464916 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.037290e+05 Mflops = 9.11 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000644126; expected ratio = 1e-07obtained abs = 5.61354e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000698068; expected ratio = 0.0001obtained abs = 0.18285; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000444174 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00036083; expected ratio = 1e-07obtained abs = 3.14461e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000405341; expected ratio = 0.0001obtained abs = 0.106157; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000215573; expected ratio = 1e-07obtained abs = 1.8787e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000264975; expected ratio = 0.0001obtained abs = 0.0693876; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00013652; expected ratio = 1e-07obtained abs = 1.18976e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000188641; expected ratio = 0.0001obtained abs = 0.0493949; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.02 -Solve flops = 2.267600e+04 Mflops = 1.36 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.12091e-05; expected ratio = 1e-07obtained abs = 7.94878e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000141988; expected ratio = 0.0001obtained abs = 0.0371768; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000511169 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.387e-05; expected ratio = 1e-07obtained abs = 5.56621e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000110556; expected ratio = 0.0001obtained abs = 0.0289458; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.64685e-05; expected ratio = 1e-07obtained abs = 4.04969e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.77486e-05; expected ratio = 0.0001obtained abs = 0.0229738; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.47954e-05; expected ratio = 1e-07obtained abs = 3.03239e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.03507e-05; expected ratio = 0.0001obtained abs = 0.0184184; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000507116 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.65936e-05; expected ratio = 1e-07obtained abs = 2.31761e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.66788e-05; expected ratio = 0.0001obtained abs = 0.0148388; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.033690e+05 Mflops = 18.20 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.06141e-05; expected ratio = 1e-07obtained abs = 1.7965e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.57661e-05; expected ratio = 0.0001obtained abs = 0.0119817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.61343e-05; expected ratio = 1e-07obtained abs = 1.40609e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.69932e-05; expected ratio = 0.0001obtained abs = 0.00968481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.27132e-05; expected ratio = 1e-07obtained abs = 1.10794e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.9922e-05; expected ratio = 0.0001obtained abs = 0.00783352; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000469923 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.033690e+05 Mflops = 9.10 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.00657e-05; expected ratio = 1e-07obtained abs = 8.77213e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.42196e-05; expected ratio = 0.0001obtained abs = 0.00634061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.68 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.68 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0483284; expected ratio = 1e-07obtained abs = 0.000401934; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0192212; expected ratio = 0.0001obtained abs = 5.06054; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000443935 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00252645; expected ratio = 1e-07obtained abs = 2.10001e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0125718; expected ratio = 0.0001obtained abs = 3.31905; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000460863 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00125664; expected ratio = 1e-07obtained abs = 1.04452e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00121948; expected ratio = 0.0001obtained abs = 0.32187; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000713012; expected ratio = 1e-07obtained abs = 5.92654e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000603613; expected ratio = 0.0001obtained abs = 0.159291; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000429241; expected ratio = 1e-07obtained abs = 3.56782e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000353966; expected ratio = 0.0001obtained abs = 0.0933994; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000270079; expected ratio = 1e-07obtained abs = 2.24486e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000233391; expected ratio = 0.0001obtained abs = 0.0615787; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000176454; expected ratio = 1e-07obtained abs = 1.46666e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00016739; expected ratio = 0.0001obtained abs = 0.0441624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000444889 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00011941; expected ratio = 1e-07obtained abs = 9.92514e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126998; expected ratio = 0.0001obtained abs = 0.0335045; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.35357e-05; expected ratio = 1e-07obtained abs = 6.94335e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.97877e-05; expected ratio = 0.0001obtained abs = 0.0263251; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000442982 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.02293e-05; expected ratio = 1e-07obtained abs = 5.00615e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.99777e-05; expected ratio = 0.0001obtained abs = 0.0210985; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.45614e-05; expected ratio = 1e-07obtained abs = 3.70387e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.47341e-05; expected ratio = 0.0001obtained abs = 0.017077; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000456095 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.36643e-05; expected ratio = 1e-07obtained abs = 2.79812e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.25989e-05; expected ratio = 0.0001obtained abs = 0.0138755; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.58445e-05; expected ratio = 1e-07obtained abs = 2.14815e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.27646e-05; expected ratio = 0.0001obtained abs = 0.0112812; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.00813e-05; expected ratio = 1e-07obtained abs = 1.66912e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.47349e-05; expected ratio = 0.0001obtained abs = 0.0091629; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000446081 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.57419e-05; expected ratio = 1e-07obtained abs = 1.30843e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.81669e-05; expected ratio = 0.0001obtained abs = 0.00743027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.033690e+05 Mflops = 6.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.24204e-05; expected ratio = 1e-07obtained abs = 1.03236e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.28004e-05; expected ratio = 0.0001obtained abs = 0.00601459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.84665e-06; expected ratio = 1e-07obtained abs = 8.18436e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.84256e-05; expected ratio = 0.0001obtained abs = 0.00486055; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.69 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.69 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000458002 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.830380e+05 Mflops = 8.49 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0514344; expected ratio = 1e-07obtained abs = 0.000406768; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0220648; expected ratio = 0.0001obtained abs = 5.7394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00244717; expected ratio = 1e-07obtained abs = 1.93368e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0136991; expected ratio = 0.0001obtained abs = 3.57362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.00049305 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00116039; expected ratio = 1e-07obtained abs = 9.16886e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00125243; expected ratio = 0.0001obtained abs = 0.326675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.830380e+05 Mflops = 8.49 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000662189; expected ratio = 1e-07obtained abs = 5.23226e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000647788; expected ratio = 0.0001obtained abs = 0.168946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.830380e+05 Mflops = 8.49 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000400418; expected ratio = 1e-07obtained abs = 3.16387e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00039255; expected ratio = 0.0001obtained abs = 0.102369; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000250883; expected ratio = 1e-07obtained abs = 1.98232e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000257217; expected ratio = 0.0001obtained abs = 0.0670728; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000485182 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000161042; expected ratio = 1e-07obtained abs = 1.27245e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000176545; expected ratio = 0.0001obtained abs = 0.0460344; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000475883 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000105389; expected ratio = 1e-07obtained abs = 8.32716e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000124948; expected ratio = 0.0001obtained abs = 0.0325793; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.830380e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.01986e-05; expected ratio = 1e-07obtained abs = 5.54663e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.04889e-05; expected ratio = 0.0001obtained abs = 0.0235939; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.75897e-05; expected ratio = 1e-07obtained abs = 3.76021e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.67815e-05; expected ratio = 0.0001obtained abs = 0.0174122; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000484943 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.28541e-05; expected ratio = 1e-07obtained abs = 2.5959e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.00808e-05; expected ratio = 0.0001obtained abs = 0.0130577; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.31095e-05; expected ratio = 1e-07obtained abs = 1.82596e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.80687e-05; expected ratio = 0.0001obtained abs = 0.00992567; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.830380e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.65638e-05; expected ratio = 1e-07obtained abs = 1.30876e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.92643e-05; expected ratio = 0.0001obtained abs = 0.00763006; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000457048 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.830380e+05 Mflops = 8.49 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.20906e-05; expected ratio = 1e-07obtained abs = 9.55314e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.27012e-05; expected ratio = 0.0001obtained abs = 0.00591886; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.7 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.7 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.828100e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0556339; expected ratio = 1e-07obtained abs = 0.000416623; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0219292; expected ratio = 0.0001obtained abs = 5.73556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000455141 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.828100e+05 Mflops = 8.48 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00298297; expected ratio = 1e-07obtained abs = 2.23116e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.014889; expected ratio = 0.0001obtained abs = 3.90781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00139467; expected ratio = 1e-07obtained abs = 1.04314e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00161883; expected ratio = 0.0001obtained abs = 0.424828; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000808757; expected ratio = 1e-07obtained abs = 6.04909e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000867088; expected ratio = 0.0001obtained abs = 0.227517; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000451088 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.828100e+05 Mflops = 16.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000503586; expected ratio = 1e-07obtained abs = 3.76657e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00053564; expected ratio = 0.0001obtained abs = 0.140531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.828100e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000327727; expected ratio = 1e-07obtained abs = 2.45123e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000357899; expected ratio = 0.0001obtained abs = 0.0938904; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000219338; expected ratio = 1e-07obtained abs = 1.64053e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000250644; expected ratio = 0.0001obtained abs = 0.0657489; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00014973; expected ratio = 1e-07obtained abs = 1.1199e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000180838; expected ratio = 0.0001obtained abs = 0.0474348; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000103855; expected ratio = 1e-07obtained abs = 7.76779e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000133341; expected ratio = 0.0001obtained abs = 0.0349747; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.828100e+05 Mflops = 8.48 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.30751e-05; expected ratio = 1e-07obtained abs = 5.46564e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100131; expected ratio = 0.0001obtained abs = 0.0262632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452995 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.828100e+05 Mflops = 16.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.21352e-05; expected ratio = 1e-07obtained abs = 3.89945e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.64558e-05; expected ratio = 0.0001obtained abs = 0.0200529; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000449181 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.77153e-05; expected ratio = 1e-07obtained abs = 2.82092e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.92904e-05; expected ratio = 0.0001obtained abs = 0.0155504; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.00045085 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.76684e-05; expected ratio = 1e-07obtained abs = 2.06946e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.66364e-05; expected ratio = 0.0001obtained abs = 0.0122314; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.828100e+05 Mflops = 8.48 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.05835e-05; expected ratio = 1e-07obtained abs = 1.53954e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.7148e-05; expected ratio = 0.0001obtained abs = 0.00974276; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000520945 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.828100e+05 Mflops = 8.48 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.55236e-05; expected ratio = 1e-07obtained abs = 1.16108e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.99108e-05; expected ratio = 0.0001obtained abs = 0.00784459; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.1861e-05; expected ratio = 1e-07obtained abs = 8.87145e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.43e-05; expected ratio = 0.0001obtained abs = 0.00637304; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.71 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 144 - - Mesh vertices: 124 - Mesh triangles: 144 - Mesh edges: 234 - Mesh exterior boundary edges: 36 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 36 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.71 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.828100e+05 Mflops = 5.66 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0597204; expected ratio = 1e-07obtained abs = 0.000421664; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0246721; expected ratio = 0.0001obtained abs = 6.37407; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000452042 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00312654; expected ratio = 1e-07obtained abs = 2.20394e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0161885; expected ratio = 0.0001obtained abs = 4.19583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000446796 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00133592; expected ratio = 1e-07obtained abs = 9.41657e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00160568; expected ratio = 0.0001obtained abs = 0.416136; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000769987; expected ratio = 1e-07obtained abs = 5.42746e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000865835; expected ratio = 0.0001obtained abs = 0.224367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000741005 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.839200e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000486027; expected ratio = 1e-07obtained abs = 3.42589e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000555902; expected ratio = 0.0001obtained abs = 0.144037; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000326457; expected ratio = 1e-07obtained abs = 2.30111e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000386946; expected ratio = 0.0001obtained abs = 0.10025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000448942 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000228533; expected ratio = 1e-07obtained abs = 1.61087e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000283837; expected ratio = 0.0001obtained abs = 0.073531; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000445127 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000164708; expected ratio = 1e-07obtained abs = 1.16098e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000215596; expected ratio = 0.0001obtained abs = 0.0558489; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.839200e+05 Mflops = 8.52 -Solve time = 0.02 -Solve flops = 2.215200e+04 Mflops = 1.33 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000121397; expected ratio = 1e-07obtained abs = 8.5569e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000167831; expected ratio = 0.0001obtained abs = 0.0434733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000449896 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.839200e+05 Mflops = 8.52 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.1153e-05; expected ratio = 1e-07obtained abs = 6.42511e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000133071; expected ratio = 0.0001obtained abs = 0.0344678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.95585e-05; expected ratio = 1e-07obtained abs = 4.90298e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000107029; expected ratio = 0.0001obtained abs = 0.0277215; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.38435e-05; expected ratio = 1e-07obtained abs = 3.79527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.7058e-05; expected ratio = 0.0001obtained abs = 0.0225481; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.839200e+05 Mflops = 17.04 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.22076e-05; expected ratio = 1e-07obtained abs = 2.97509e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.14381e-05; expected ratio = 0.0001obtained abs = 0.0185021; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.34523e-05; expected ratio = 1e-07obtained abs = 2.35796e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.90165e-05; expected ratio = 0.0001obtained abs = 0.0152847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000450134 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.67653e-05; expected ratio = 1e-07obtained abs = 1.88661e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.90014e-05; expected ratio = 0.0001obtained abs = 0.0126906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447989 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.839200e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.15874e-05; expected ratio = 1e-07obtained abs = 1.52163e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.08367e-05; expected ratio = 0.0001obtained abs = 0.0105759; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000459909 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.839200e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.75284e-05; expected ratio = 1e-07obtained abs = 1.23552e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.4123e-05; expected ratio = 0.0001obtained abs = 0.00883712; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000447035 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.4312e-05; expected ratio = 1e-07obtained abs = 1.00881e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.85664e-05; expected ratio = 0.0001obtained abs = 0.00739801; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,144) -time: 0.000445843 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.839200e+05 Mflops = 8.52 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.17394e-05; expected ratio = 1e-07obtained abs = 8.27477e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.39455e-05; expected ratio = 0.0001obtained abs = 0.00620126; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.72 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 145 - - Mesh vertices: 124 - Mesh triangles: 145 - Mesh edges: 235 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.72 -matrix_partition : [9](0,28,56,84,112,140,168,196,229) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000473976 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.065809; expected ratio = 1e-07obtained abs = 0.000436067; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0803949; expected ratio = 0.0001obtained abs = 20.6847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.900930e+05 Mflops = 5.80 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00719994; expected ratio = 1e-07obtained abs = 4.75929e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0303109; expected ratio = 0.0001obtained abs = 7.82149; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000566006 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.900930e+05 Mflops = 8.70 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00481365; expected ratio = 1e-07obtained abs = 3.18295e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0188317; expected ratio = 0.0001obtained abs = 4.86362; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000467062 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00318786; expected ratio = 1e-07obtained abs = 2.10855e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010944; expected ratio = 0.0001obtained abs = 2.82879; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000466108 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00196394; expected ratio = 1e-07obtained abs = 1.29921e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00614343; expected ratio = 0.0001obtained abs = 1.58902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.900930e+05 Mflops = 17.41 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0011847; expected ratio = 1e-07obtained abs = 7.83774e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00352377; expected ratio = 0.0001obtained abs = 0.911876; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.900930e+05 Mflops = 5.80 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000721351; expected ratio = 1e-07obtained abs = 4.77247e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00210162; expected ratio = 0.0001obtained abs = 0.544022; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000449802; expected ratio = 1e-07obtained abs = 2.97594e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00131598; expected ratio = 0.0001obtained abs = 0.34072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000465155 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000289216; expected ratio = 1e-07obtained abs = 1.91349e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00087323; expected ratio = 0.0001obtained abs = 0.226115; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000471115 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000192668; expected ratio = 1e-07obtained abs = 1.27472e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000615041; expected ratio = 0.0001obtained abs = 0.159271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.900930e+05 Mflops = 5.80 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133532; expected ratio = 1e-07obtained abs = 8.83463e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000454118; expected ratio = 0.0001obtained abs = 0.117604; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.00048089 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.900930e+05 Mflops = 17.41 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.64984e-05; expected ratio = 1e-07obtained abs = 6.38445e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000344738; expected ratio = 0.0001obtained abs = 0.0892802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000463963 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.25985e-05; expected ratio = 1e-07obtained abs = 4.8032e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000265024; expected ratio = 0.0001obtained abs = 0.0686373; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000462055 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.65399e-05; expected ratio = 1e-07obtained abs = 3.74074e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000204826; expected ratio = 0.0001obtained abs = 0.0530474; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000461102 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.900930e+05 Mflops = 5.80 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.52245e-05; expected ratio = 1e-07obtained abs = 2.9921e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000158866; expected ratio = 0.0001obtained abs = 0.0411448; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.00046587 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.900930e+05 Mflops = 5.80 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.68628e-05; expected ratio = 1e-07obtained abs = 2.43888e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000123758; expected ratio = 0.0001obtained abs = 0.0320522; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000468016 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.04257e-05; expected ratio = 1e-07obtained abs = 2.01299e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.69617e-05; expected ratio = 0.0001obtained abs = 0.0251124; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.53135e-05; expected ratio = 1e-07obtained abs = 1.67477e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.64844e-05; expected ratio = 0.0001obtained abs = 0.019809; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000463009 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.11643e-05; expected ratio = 1e-07obtained abs = 1.40025e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.0771e-05; expected ratio = 0.0001obtained abs = 0.0157394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000485897 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.900930e+05 Mflops = 5.80 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.77481e-05; expected ratio = 1e-07obtained abs = 1.17423e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.86349e-05; expected ratio = 0.0001obtained abs = 0.0125962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,145) -time: 0.000467777 -"finished parallel building" : finished parallel building -matrix size in solver: 229 -RHS size in solver: 229 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.49096e-05; expected ratio = 1e-07obtained abs = 9.86431e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.91869e-05; expected ratio = 0.0001obtained abs = 0.0101492; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.73 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 124 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - - Mesh vertices: 124 - Mesh triangles: 191 - Mesh edges: 314 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 191 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 124 - Input triangles: 145 - - Mesh vertices: 125 - Mesh triangles: 147 - Mesh edges: 238 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.73 -matrix_partition : [9](0,29,58,87,116,145,174,203,232) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.02 -Solve flops = 2.187800e+04 Mflops = 1.31 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0720966; expected ratio = 1e-07obtained abs = 0.000446508; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0407456; expected ratio = 0.0001obtained abs = 10.6557; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00630868; expected ratio = 1e-07obtained abs = 3.8929e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0225951; expected ratio = 0.0001obtained abs = 5.95433; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00262997; expected ratio = 1e-07obtained abs = 1.62247e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00397624; expected ratio = 0.0001obtained abs = 1.04896; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00146967; expected ratio = 1e-07obtained abs = 9.06649e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00203826; expected ratio = 0.0001obtained abs = 0.537802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00728202 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000877947; expected ratio = 1e-07obtained abs = 5.41615e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00141268; expected ratio = 0.0001obtained abs = 0.372732; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000531912 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000575287; expected ratio = 1e-07obtained abs = 3.54903e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00109246; expected ratio = 0.0001obtained abs = 0.28822; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000419791; expected ratio = 1e-07obtained abs = 2.58979e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000899964; expected ratio = 0.0001obtained abs = 0.237411; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000336036; expected ratio = 1e-07obtained abs = 2.0731e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000771308; expected ratio = 0.0001obtained abs = 0.203453; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00028599; expected ratio = 1e-07obtained abs = 1.76439e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000676311; expected ratio = 0.0001obtained abs = 0.178379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000589848 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000251762; expected ratio = 1e-07obtained abs = 1.55324e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000600074; expected ratio = 0.0001obtained abs = 0.158258; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000565052 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000225304; expected ratio = 1e-07obtained abs = 1.39003e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000535299; expected ratio = 0.0001obtained abs = 0.141165; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000203024; expected ratio = 1e-07obtained abs = 1.25259e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000478401; expected ratio = 0.0001obtained abs = 0.126152; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.02 -Solve flops = 2.187800e+04 Mflops = 1.31 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000183292; expected ratio = 1e-07obtained abs = 1.13086e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00042756; expected ratio = 0.0001obtained abs = 0.112739; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000165354; expected ratio = 1e-07obtained abs = 1.02021e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000381781; expected ratio = 0.0001obtained abs = 0.100663; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000511169 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000148862; expected ratio = 1e-07obtained abs = 9.18465e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000340452; expected ratio = 0.0001obtained abs = 0.0897621; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000507832 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133652; expected ratio = 1e-07obtained abs = 8.24625e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000303142; expected ratio = 0.0001obtained abs = 0.0799221; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000119641; expected ratio = 1e-07obtained abs = 7.38188e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000269505; expected ratio = 0.0001obtained abs = 0.0710516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000504971 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000106783; expected ratio = 1e-07obtained abs = 6.58857e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00023924; expected ratio = 0.0001obtained abs = 0.0630708; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.50363e-05; expected ratio = 1e-07obtained abs = 5.86387e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00021207; expected ratio = 0.0001obtained abs = 0.0559068; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.43595e-05; expected ratio = 1e-07obtained abs = 5.20513e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000187737; expected ratio = 0.0001obtained abs = 0.049491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.47027e-05; expected ratio = 1e-07obtained abs = 4.60932e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000165994; expected ratio = 0.0001obtained abs = 0.0437583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000508785 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.60092e-05; expected ratio = 1e-07obtained abs = 4.07293e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000146607; expected ratio = 0.0001obtained abs = 0.0386473; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.82164e-05; expected ratio = 1e-07obtained abs = 3.59212e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000129358; expected ratio = 0.0001obtained abs = 0.0340997; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.12581e-05; expected ratio = 1e-07obtained abs = 3.16278e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000114038; expected ratio = 0.0001obtained abs = 0.030061; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000510931 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.50663e-05; expected ratio = 1e-07obtained abs = 2.78074e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100456; expected ratio = 0.0001obtained abs = 0.0264804; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000507832 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.02 -Solve flops = 2.187800e+04 Mflops = 1.31 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.95734e-05; expected ratio = 1e-07obtained abs = 2.44182e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.84318e-05; expected ratio = 0.0001obtained abs = 0.0233107; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.47132e-05; expected ratio = 1e-07obtained abs = 2.14194e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.78019e-05; expected ratio = 0.0001obtained abs = 0.0205085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.04229e-05; expected ratio = 1e-07obtained abs = 1.87721e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.84154e-05; expected ratio = 0.0001obtained abs = 0.0180342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.6643e-05; expected ratio = 1e-07obtained abs = 1.64398e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.01356e-05; expected ratio = 0.0001obtained abs = 0.0158516; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.33184e-05; expected ratio = 1e-07obtained abs = 1.43884e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.28384e-05; expected ratio = 0.0001obtained abs = 0.013928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000519991 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.03984e-05; expected ratio = 1e-07obtained abs = 1.25867e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.64122e-05; expected ratio = 0.0001obtained abs = 0.012234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000507116 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.78369e-05; expected ratio = 1e-07obtained abs = 1.10061e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.07567e-05; expected ratio = 0.0001obtained abs = 0.0107433; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.55921e-05; expected ratio = 1e-07obtained abs = 9.62102e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.57824e-05; expected ratio = 0.0001obtained abs = 0.00943203; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.74 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 125 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - - Mesh vertices: 125 - Mesh triangles: 193 - Mesh edges: 317 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 193 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - Input triangles: 147 - - Mesh vertices: 125 - Mesh triangles: 147 - Mesh edges: 238 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.74 -matrix_partition : [9](0,29,58,87,116,145,174,203,232) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0754052; expected ratio = 1e-07obtained abs = 0.000432905; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.060996; expected ratio = 0.0001obtained abs = 15.4188; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000505924 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00523338; expected ratio = 1e-07obtained abs = 2.99163e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0216144; expected ratio = 0.0001obtained abs = 5.48364; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00165226; expected ratio = 1e-07obtained abs = 9.44115e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0022589; expected ratio = 0.0001obtained abs = 0.573267; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00092376; expected ratio = 1e-07obtained abs = 5.27799e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00101859; expected ratio = 0.0001obtained abs = 0.258502; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000558477; expected ratio = 1e-07obtained abs = 3.19078e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000663757; expected ratio = 0.0001obtained abs = 0.168447; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000506878 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000358393; expected ratio = 1e-07obtained abs = 2.04758e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000476523; expected ratio = 0.0001obtained abs = 0.120928; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000507832 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000244053; expected ratio = 1e-07obtained abs = 1.39431e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000365437; expected ratio = 0.0001obtained abs = 0.0927358; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000510216 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000175475; expected ratio = 1e-07obtained abs = 1.0025e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000294219; expected ratio = 0.0001obtained abs = 0.0746618; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000513077 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000132027; expected ratio = 1e-07obtained abs = 7.54267e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000244677; expected ratio = 0.0001obtained abs = 0.062089; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000526905 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000102918; expected ratio = 1e-07obtained abs = 5.87966e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000207603; expected ratio = 0.0001obtained abs = 0.0526803; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.23984e-05; expected ratio = 1e-07obtained abs = 4.70735e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000178308; expected ratio = 0.0001obtained abs = 0.0452462; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.73056e-05; expected ratio = 1e-07obtained abs = 3.84509e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000154315; expected ratio = 0.0001obtained abs = 0.0391574; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.58242e-05; expected ratio = 1e-07obtained abs = 3.18916e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134217; expected ratio = 0.0001obtained abs = 0.0340573; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.68573e-05; expected ratio = 1e-07obtained abs = 2.67688e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000117146; expected ratio = 0.0001obtained abs = 0.0297253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000507832 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.97076e-05; expected ratio = 1e-07obtained abs = 2.26842e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000102513; expected ratio = 0.0001obtained abs = 0.0260121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.39109e-05; expected ratio = 1e-07obtained abs = 1.93726e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.98927e-05; expected ratio = 0.0001obtained abs = 0.0228095; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000611067 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.91463e-05; expected ratio = 1e-07obtained abs = 1.66507e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.89588e-05; expected ratio = 0.0001obtained abs = 0.020035; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00051403 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.51848e-05; expected ratio = 1e-07obtained abs = 1.43875e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.94535e-05; expected ratio = 0.0001obtained abs = 0.017623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.18587e-05; expected ratio = 1e-07obtained abs = 1.24874e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.11674e-05; expected ratio = 0.0001obtained abs = 0.0155205; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.90429e-05; expected ratio = 1e-07obtained abs = 1.08788e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.39276e-05; expected ratio = 0.0001obtained abs = 0.0136834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000521183 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.66422e-05; expected ratio = 1e-07obtained abs = 9.50728e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.759e-05; expected ratio = 0.0001obtained abs = 0.0120753; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.75 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 125 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - - Mesh vertices: 125 - Mesh triangles: 193 - Mesh edges: 317 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 193 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - Input triangles: 147 - - Mesh vertices: 125 - Mesh triangles: 147 - Mesh edges: 238 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.75 -matrix_partition : [9](0,29,58,87,116,145,174,203,232) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000514984 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0813058; expected ratio = 1e-07obtained abs = 0.000429705; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0384448; expected ratio = 0.0001obtained abs = 9.9616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000527859 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00588336; expected ratio = 1e-07obtained abs = 3.09293e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.02127; expected ratio = 0.0001obtained abs = 5.52847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00148771; expected ratio = 1e-07obtained abs = 7.81709e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00202269; expected ratio = 0.0001obtained abs = 0.525786; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000834062; expected ratio = 1e-07obtained abs = 4.38217e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000834777; expected ratio = 0.0001obtained abs = 0.216983; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000516378; expected ratio = 1e-07obtained abs = 2.71297e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000515331; expected ratio = 0.0001obtained abs = 0.133944; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000338059; expected ratio = 1e-07obtained abs = 1.77608e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000344348; expected ratio = 0.0001obtained abs = 0.0895015; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000519037 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000233441; expected ratio = 1e-07obtained abs = 1.22642e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000243513; expected ratio = 0.0001obtained abs = 0.0632926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000168972; expected ratio = 1e-07obtained abs = 8.87719e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000181223; expected ratio = 0.0001obtained abs = 0.0471027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.00050807 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000127069; expected ratio = 1e-07obtained abs = 6.67571e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000140667; expected ratio = 0.0001obtained abs = 0.0365619; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000524044 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.83967e-05; expected ratio = 1e-07obtained abs = 5.16936e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000112671; expected ratio = 0.0001obtained abs = 0.0292854; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.658700e+05 Mflops = 15.95 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.78871e-05; expected ratio = 1e-07obtained abs = 4.09186e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.22607e-05; expected ratio = 0.0001obtained abs = 0.0239804; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000511885 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.26854e-05; expected ratio = 1e-07obtained abs = 3.29322e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.67133e-05; expected ratio = 0.0001obtained abs = 0.0199394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.11054e-05; expected ratio = 1e-07obtained abs = 2.68486e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.44852e-05; expected ratio = 0.0001obtained abs = 0.0167611; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509024 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.2098e-05; expected ratio = 1e-07obtained abs = 2.21164e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.46484e-05; expected ratio = 0.0001obtained abs = 0.0142043; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.658700e+05 Mflops = 7.98 -Solve time = 0.02 -Solve flops = 2.187800e+04 Mflops = 1.31 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.49766e-05; expected ratio = 1e-07obtained abs = 1.83751e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.66067e-05; expected ratio = 0.0001obtained abs = 0.0121141; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.92722e-05; expected ratio = 1e-07obtained abs = 1.53783e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.99528e-05; expected ratio = 0.0001obtained abs = 0.0103847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000509977 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.46529e-05; expected ratio = 1e-07obtained abs = 1.29515e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.4395e-05; expected ratio = 0.0001obtained abs = 0.00894005; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000530958 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.08771e-05; expected ratio = 1e-07obtained abs = 1.09679e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.97162e-05; expected ratio = 0.0001obtained abs = 0.00772393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,147) -time: 0.000531197 -"finished parallel building" : finished parallel building -matrix size in solver: 232 -RHS size in solver: 232 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.658700e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.77654e-05; expected ratio = 1e-07obtained abs = 9.33311e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.57514e-05; expected ratio = 0.0001obtained abs = 0.00669337; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.76 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 125 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - - Mesh vertices: 125 - Mesh triangles: 193 - Mesh edges: 317 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 193 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 125 - Input triangles: 147 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 1 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.76 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0928094; expected ratio = 1e-07obtained abs = 0.000450945; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.035984; expected ratio = 0.0001obtained abs = 9.17568; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0102918; expected ratio = 1e-07obtained abs = 4.96203e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.025662; expected ratio = 0.0001obtained abs = 6.58544; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00362408; expected ratio = 1e-07obtained abs = 1.7456e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00318541; expected ratio = 0.0001obtained abs = 0.818253; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00203122; expected ratio = 1e-07obtained abs = 9.78155e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00139525; expected ratio = 0.0001obtained abs = 0.358501; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00125621; expected ratio = 1e-07obtained abs = 6.04881e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000961152; expected ratio = 0.0001obtained abs = 0.246994; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000820528; expected ratio = 1e-07obtained abs = 3.95074e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000731975; expected ratio = 0.0001obtained abs = 0.188121; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000562043; expected ratio = 1e-07obtained abs = 2.70608e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000590191; expected ratio = 0.0001obtained abs = 0.151697; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000403628; expected ratio = 1e-07obtained abs = 1.94332e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000493404; expected ratio = 0.0001obtained abs = 0.126831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560045 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000303357; expected ratio = 1e-07obtained abs = 1.46054e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000421057; expected ratio = 0.0001obtained abs = 0.108243; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571966 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000237176; expected ratio = 1e-07obtained abs = 1.1419e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000363112; expected ratio = 0.0001obtained abs = 0.0933537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191211; expected ratio = 1e-07obtained abs = 9.20599e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000314685; expected ratio = 0.0001obtained abs = 0.0809088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000157578; expected ratio = 1e-07obtained abs = 7.5867e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000273296; expected ratio = 0.0001obtained abs = 0.0702714; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.02 -Solve flops = 2.275000e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000131826; expected ratio = 1e-07obtained abs = 6.34688e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000237552; expected ratio = 0.0001obtained abs = 0.0610839; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559807 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000111413; expected ratio = 1e-07obtained abs = 5.36408e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000206554; expected ratio = 0.0001obtained abs = 0.0531153; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.48304e-05; expected ratio = 1e-07obtained abs = 4.5657e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000179634; expected ratio = 0.0001obtained abs = 0.0461946; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.11328e-05; expected ratio = 1e-07obtained abs = 3.90622e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000156252; expected ratio = 0.0001obtained abs = 0.0401831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.96892e-05; expected ratio = 1e-07obtained abs = 3.35527e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000135947; expected ratio = 0.0001obtained abs = 0.0349624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.00523e-05; expected ratio = 1e-07obtained abs = 2.89129e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000118319; expected ratio = 0.0001obtained abs = 0.0304295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.18893e-05; expected ratio = 1e-07obtained abs = 2.49828e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000103015; expected ratio = 0.0001obtained abs = 0.0264943; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.49432e-05; expected ratio = 1e-07obtained abs = 2.16385e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.97295e-05; expected ratio = 0.0001obtained abs = 0.0230778; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.90105e-05; expected ratio = 1e-07obtained abs = 1.87822e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.81933e-05; expected ratio = 0.0001obtained abs = 0.0201112; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000578165 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.3927e-05; expected ratio = 1e-07obtained abs = 1.63347e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.81733e-05; expected ratio = 0.0001obtained abs = 0.0175343; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.95589e-05; expected ratio = 1e-07obtained abs = 1.42316e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.94668e-05; expected ratio = 0.0001obtained abs = 0.0152952; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.57959e-05; expected ratio = 1e-07obtained abs = 1.24198e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.18982e-05; expected ratio = 0.0001obtained abs = 0.0133486; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.25464e-05; expected ratio = 1e-07obtained abs = 1.08553e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.53155e-05; expected ratio = 0.0001obtained abs = 0.0116556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000653982 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.97344e-05; expected ratio = 1e-07obtained abs = 9.50146e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.95874e-05; expected ratio = 0.0001obtained abs = 0.0101824; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.77 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.77 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0976634; expected ratio = 1e-07obtained abs = 0.00042883; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0359696; expected ratio = 0.0001obtained abs = 9.11847; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0104698; expected ratio = 1e-07obtained abs = 4.5568e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0255375; expected ratio = 0.0001obtained abs = 6.50852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00332411; expected ratio = 1e-07obtained abs = 1.44512e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00304771; expected ratio = 0.0001obtained abs = 0.777455; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552177 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00191799; expected ratio = 1e-07obtained abs = 8.33624e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00113371; expected ratio = 0.0001obtained abs = 0.289295; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0012326; expected ratio = 1e-07obtained abs = 5.35673e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000749269; expected ratio = 0.0001obtained abs = 0.191234; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000830901; expected ratio = 1e-07obtained abs = 3.61075e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000557128; expected ratio = 0.0001obtained abs = 0.142219; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000581951; expected ratio = 1e-07obtained abs = 2.52879e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000435798; expected ratio = 0.0001obtained abs = 0.111264; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552177 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000421891; expected ratio = 1e-07obtained abs = 1.83321e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000352982; expected ratio = 0.0001obtained abs = 0.090133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000315644; expected ratio = 1e-07obtained abs = 1.37151e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000292823; expected ratio = 0.0001obtained abs = 0.0747808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.275000e+04 Mflops = 1.36 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000242831; expected ratio = 1e-07obtained abs = 1.05511e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000246606; expected ratio = 0.0001obtained abs = 0.0629846; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191266; expected ratio = 1e-07obtained abs = 8.31049e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000209536; expected ratio = 0.0001obtained abs = 0.0535217; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000153547; expected ratio = 1e-07obtained abs = 6.67156e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000178948; expected ratio = 0.0001obtained abs = 0.0457123; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000125121; expected ratio = 1e-07obtained abs = 5.43642e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000153282; expected ratio = 0.0001obtained abs = 0.0391587; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00010314; expected ratio = 1e-07obtained abs = 4.48135e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000131549; expected ratio = 0.0001obtained abs = 0.0336085; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.57832e-05; expected ratio = 1e-07obtained abs = 3.72718e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000113057; expected ratio = 0.0001obtained abs = 0.0288855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.18484e-05; expected ratio = 1e-07obtained abs = 3.12172e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.72827e-05; expected ratio = 0.0001obtained abs = 0.0248563; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.835290e+05 Mflops = 17.01 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.05169e-05; expected ratio = 1e-07obtained abs = 2.62937e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.38069e-05; expected ratio = 0.0001obtained abs = 0.0214139; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000701904 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.835290e+05 Mflops = 5.67 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.12105e-05; expected ratio = 1e-07obtained abs = 2.22502e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.22826e-05; expected ratio = 0.0001obtained abs = 0.0184698; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000592947 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.35076e-05; expected ratio = 1e-07obtained abs = 1.89034e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.24178e-05; expected ratio = 0.0001obtained abs = 0.0159496; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.70923e-05; expected ratio = 1e-07obtained abs = 1.6116e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.39653e-05; expected ratio = 0.0001obtained abs = 0.01379; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.275000e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.17222e-05; expected ratio = 1e-07obtained abs = 1.37828e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.67151e-05; expected ratio = 0.0001obtained abs = 0.0119376; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.275000e+04 Mflops = 1.36 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.72075e-05; expected ratio = 1e-07obtained abs = 1.18212e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.04891e-05; expected ratio = 0.0001obtained abs = 0.0103467; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.33979e-05; expected ratio = 1e-07obtained abs = 1.0166e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.5136e-05; expected ratio = 0.0001obtained abs = 0.00897889; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.01726e-05; expected ratio = 1e-07obtained abs = 8.76464e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.05277e-05; expected ratio = 0.0001obtained abs = 0.00780134; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.78 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.78 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.105443; expected ratio = 1e-07obtained abs = 0.000414532; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.032447; expected ratio = 0.0001obtained abs = 8.28543; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0119013; expected ratio = 1e-07obtained abs = 4.62601e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0254423; expected ratio = 0.0001obtained abs = 6.53195; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.835290e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.275000e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00256088; expected ratio = 1e-07obtained abs = 9.93846e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00332815; expected ratio = 0.0001obtained abs = 0.855027; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00134047; expected ratio = 1e-07obtained abs = 5.20081e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00106271; expected ratio = 0.0001obtained abs = 0.273035; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552177 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000894195; expected ratio = 1e-07obtained abs = 3.46908e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000664112; expected ratio = 0.0001obtained abs = 0.170623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000629055; expected ratio = 1e-07obtained abs = 2.44036e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000480022; expected ratio = 0.0001obtained abs = 0.123325; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000459967; expected ratio = 1e-07obtained abs = 1.78435e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000360982; expected ratio = 0.0001obtained abs = 0.0927416; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0003479; expected ratio = 1e-07obtained abs = 1.34958e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000278354; expected ratio = 0.0001obtained abs = 0.0715133; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000270808; expected ratio = 1e-07obtained abs = 1.05051e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000219377; expected ratio = 0.0001obtained abs = 0.0563615; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000215805; expected ratio = 1e-07obtained abs = 8.37136e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000176327; expected ratio = 0.0001obtained abs = 0.0453012; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000175195; expected ratio = 1e-07obtained abs = 6.79596e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000144171; expected ratio = 0.0001obtained abs = 0.03704; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.276800e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000144278; expected ratio = 1e-07obtained abs = 5.59664e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000119587; expected ratio = 0.0001obtained abs = 0.0307238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000120119; expected ratio = 1e-07obtained abs = 4.65949e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100364; expected ratio = 0.0001obtained abs = 0.0257852; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000100835; expected ratio = 1e-07obtained abs = 3.91141e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.50255e-05; expected ratio = 0.0001obtained abs = 0.0218444; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.837690e+05 Mflops = 17.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.51771e-05; expected ratio = 1e-07obtained abs = 3.30405e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.25679e-05; expected ratio = 0.0001obtained abs = 0.0186438; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.2296e-05; expected ratio = 1e-07obtained abs = 2.80438e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.22991e-05; expected ratio = 0.0001obtained abs = 0.0160055; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.15903e-05; expected ratio = 1e-07obtained abs = 2.3891e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.37309e-05; expected ratio = 0.0001obtained abs = 0.0138042; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.26229e-05; expected ratio = 1e-07obtained abs = 2.04125e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.65106e-05; expected ratio = 0.0001obtained abs = 0.0119491; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.837690e+05 Mflops = 17.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.50657e-05; expected ratio = 1e-07obtained abs = 1.7481e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.03771e-05; expected ratio = 0.0001obtained abs = 0.0103733; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000575066 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.86669e-05; expected ratio = 1e-07obtained abs = 1.49989e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.51332e-05; expected ratio = 0.0001obtained abs = 0.00902606; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.32287e-05; expected ratio = 1e-07obtained abs = 1.28894e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.06263e-05; expected ratio = 0.0001obtained abs = 0.00786817; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.85932e-05; expected ratio = 1e-07obtained abs = 1.10913e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.67367e-05; expected ratio = 0.0001obtained abs = 0.00686884; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.46323e-05; expected ratio = 1e-07obtained abs = 9.55488e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.33683e-05; expected ratio = 0.0001obtained abs = 0.00600345; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.79 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.79 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.117394; expected ratio = 1e-07obtained abs = 0.000407569; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0325809; expected ratio = 0.0001obtained abs = 8.28593; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0152065; expected ratio = 1e-07obtained abs = 5.20166e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0273544; expected ratio = 0.0001obtained abs = 6.98076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00289278; expected ratio = 1e-07obtained abs = 9.8721e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00386401; expected ratio = 0.0001obtained abs = 0.986947; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00118637; expected ratio = 1e-07obtained abs = 4.04706e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00110773; expected ratio = 0.0001obtained abs = 0.282962; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000772506; expected ratio = 1e-07obtained abs = 2.63501e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000638409; expected ratio = 0.0001obtained abs = 0.163072; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000547397; expected ratio = 1e-07obtained abs = 1.8671e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000449536; expected ratio = 0.0001obtained abs = 0.114823; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000664949 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000403625; expected ratio = 1e-07obtained abs = 1.37669e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000332497; expected ratio = 0.0001obtained abs = 0.0849255; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000307989; expected ratio = 1e-07obtained abs = 1.05048e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000252541; expected ratio = 0.0001obtained abs = 0.0645018; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0002421; expected ratio = 1e-07obtained abs = 8.25737e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000196227; expected ratio = 0.0001obtained abs = 0.0501176; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000195042; expected ratio = 1e-07obtained abs = 6.65227e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000155838; expected ratio = 0.0001obtained abs = 0.0398013; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000559092 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000160235; expected ratio = 1e-07obtained abs = 5.4651e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126352; expected ratio = 0.0001obtained abs = 0.0322701; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000133658; expected ratio = 1e-07obtained abs = 4.55861e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104391; expected ratio = 0.0001obtained abs = 0.0266609; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000112796; expected ratio = 1e-07obtained abs = 3.84709e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.76668e-05; expected ratio = 0.0001obtained abs = 0.0223894; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.837690e+05 Mflops = 17.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.60427e-05; expected ratio = 1e-07obtained abs = 3.27567e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.46304e-05; expected ratio = 0.0001obtained abs = 0.0190598; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.23363e-05; expected ratio = 1e-07obtained abs = 2.80819e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.42324e-05; expected ratio = 0.0001obtained abs = 0.016404; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.09569e-05; expected ratio = 1e-07obtained abs = 2.42007e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.57597e-05; expected ratio = 0.0001obtained abs = 0.0142401; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000609875 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.13994e-05; expected ratio = 1e-07obtained abs = 2.0941e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.87242e-05; expected ratio = 0.0001obtained abs = 0.0124432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.3299e-05; expected ratio = 1e-07obtained abs = 1.81783e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.27877e-05; expected ratio = 0.0001obtained abs = 0.010927; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.63844e-05; expected ratio = 1e-07obtained abs = 1.58199e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.77123e-05; expected ratio = 0.0001obtained abs = 0.00963079; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.04485e-05; expected ratio = 1e-07obtained abs = 1.37954e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.33272e-05; expected ratio = 0.0001obtained abs = 0.00851088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.533e-05; expected ratio = 1e-07obtained abs = 1.20497e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.95075e-05; expected ratio = 0.0001obtained abs = 0.00753537; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.837690e+05 Mflops = 17.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.09004e-05; expected ratio = 1e-07obtained abs = 1.05389e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.61595e-05; expected ratio = 0.0001obtained abs = 0.00668033; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.70558e-05; expected ratio = 1e-07obtained abs = 9.22765e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.3211e-05; expected ratio = 0.0001obtained abs = 0.00592734; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.8 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.8 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.132125; expected ratio = 1e-07obtained abs = 0.000398074; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.035272; expected ratio = 0.0001obtained abs = 8.95556; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0199718; expected ratio = 1e-07obtained abs = 5.90032e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.02908; expected ratio = 0.0001obtained abs = 7.42026; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000566959 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00392232; expected ratio = 1e-07obtained abs = 1.15459e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00546536; expected ratio = 0.0001obtained abs = 1.39583; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00119763; expected ratio = 1e-07obtained abs = 3.52291e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00110256; expected ratio = 0.0001obtained abs = 0.281653; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000691466; expected ratio = 1e-07obtained abs = 2.03369e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000519881; expected ratio = 0.0001obtained abs = 0.132805; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000484021; expected ratio = 1e-07obtained abs = 1.42351e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000350142; expected ratio = 0.0001obtained abs = 0.0894417; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000355119; expected ratio = 1e-07obtained abs = 1.04439e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000258552; expected ratio = 0.0001obtained abs = 0.0660431; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000269106; expected ratio = 1e-07obtained abs = 7.91416e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000197627; expected ratio = 0.0001obtained abs = 0.0504792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.276800e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00020997; expected ratio = 1e-07obtained abs = 6.17499e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000154613; expected ratio = 0.0001obtained abs = 0.0394913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000168113; expected ratio = 1e-07obtained abs = 4.94396e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000123546; expected ratio = 0.0001obtained abs = 0.0315554; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000137574; expected ratio = 1e-07obtained abs = 4.04583e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000100766; expected ratio = 0.0001obtained abs = 0.0257365; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000114619; expected ratio = 1e-07obtained abs = 3.37075e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.37942e-05; expected ratio = 0.0001obtained abs = 0.0214014; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.68776e-05; expected ratio = 1e-07obtained abs = 2.84899e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.09105e-05; expected ratio = 0.0001obtained abs = 0.0181106; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.28207e-05; expected ratio = 1e-07obtained abs = 2.4356e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.09162e-05; expected ratio = 0.0001obtained abs = 0.0155578; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.1442e-05; expected ratio = 1e-07obtained abs = 2.10097e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.29807e-05; expected ratio = 0.0001obtained abs = 0.0135309; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.20637e-05; expected ratio = 1e-07obtained abs = 1.82517e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.65311e-05; expected ratio = 0.0001obtained abs = 0.0118835; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.837690e+05 Mflops = 17.03 -Solve time = 0.02 -Solve flops = 2.276800e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.42182e-05; expected ratio = 1e-07obtained abs = 1.59445e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.11733e-05; expected ratio = 0.0001obtained abs = 0.0105151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.75747e-05; expected ratio = 1e-07obtained abs = 1.39907e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.66359e-05; expected ratio = 0.0001obtained abs = 0.0093562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.18931e-05; expected ratio = 1e-07obtained abs = 1.23199e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.27305e-05; expected ratio = 0.0001obtained abs = 0.00835874; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.69952e-05; expected ratio = 1e-07obtained abs = 1.08795e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.93252e-05; expected ratio = 0.0001obtained abs = 0.00748901; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.837690e+05 Mflops = 17.03 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 3.27455e-05; expected ratio = 1e-07obtained abs = 9.62972e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.63258e-05; expected ratio = 0.0001obtained abs = 0.00672298; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.81 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.81 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.151073; expected ratio = 1e-07obtained abs = 0.000386008; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0382462; expected ratio = 0.0001obtained abs = 9.68623; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0271019; expected ratio = 1e-07obtained abs = 6.74278e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0309163; expected ratio = 0.0001obtained abs = 7.87524; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00602558; expected ratio = 1e-07obtained abs = 1.49038e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00588436; expected ratio = 0.0001obtained abs = 1.50088; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00159788; expected ratio = 1e-07obtained abs = 3.94699e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00138772; expected ratio = 0.0001obtained abs = 0.354045; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000698169; expected ratio = 1e-07obtained abs = 1.72404e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000477457; expected ratio = 0.0001obtained abs = 0.121813; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.276800e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000457102; expected ratio = 1e-07obtained abs = 1.12867e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000281842; expected ratio = 0.0001obtained abs = 0.0719028; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000331755; expected ratio = 1e-07obtained abs = 8.19141e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000210285; expected ratio = 0.0001obtained abs = 0.0536447; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000248842; expected ratio = 1e-07obtained abs = 6.14411e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000166633; expected ratio = 0.0001obtained abs = 0.042507; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000191397; expected ratio = 1e-07obtained abs = 4.7257e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000134946; expected ratio = 0.0001obtained abs = 0.0344225; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.02 -Solve flops = 2.276800e+04 Mflops = 1.37 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000150737; expected ratio = 1e-07obtained abs = 3.72176e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000110782; expected ratio = 0.0001obtained abs = 0.0282577; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000121348; expected ratio = 1e-07obtained abs = 2.99613e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.20205e-05; expected ratio = 0.0001obtained abs = 0.0234713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.96246e-05; expected ratio = 1e-07obtained abs = 2.45976e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.72907e-05; expected ratio = 0.0001obtained abs = 0.0197137; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.31899e-05; expected ratio = 1e-07obtained abs = 2.05397e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.56073e-05; expected ratio = 0.0001obtained abs = 0.0167333; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.04687e-05; expected ratio = 1e-07obtained abs = 1.73988e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.62394e-05; expected ratio = 0.0001obtained abs = 0.0143437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.837690e+05 Mflops = 5.68 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.04061e-05; expected ratio = 1e-07obtained abs = 1.49143e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.86412e-05; expected ratio = 0.0001obtained abs = 0.0124056; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000562906 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.22869e-05; expected ratio = 1e-07obtained abs = 1.29097e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.24041e-05; expected ratio = 0.0001obtained abs = 0.0108147; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.56193e-05; expected ratio = 1e-07obtained abs = 1.12634e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.72218e-05; expected ratio = 0.0001obtained abs = 0.00949287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.837690e+05 Mflops = 8.51 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.00589e-05; expected ratio = 1e-07obtained abs = 9.89054e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.28645e-05; expected ratio = 0.0001obtained abs = 0.00838151; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.82 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.82 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.175861; expected ratio = 1e-07obtained abs = 0.000369327; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0439743; expected ratio = 0.0001obtained abs = 11.1394; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.024430e+05 Mflops = 9.07 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0380047; expected ratio = 1e-07obtained abs = 7.6902e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0330025; expected ratio = 0.0001obtained abs = 8.40895; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.025990e+05 Mflops = 9.08 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0100735; expected ratio = 1e-07obtained abs = 2.01832e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00761752; expected ratio = 0.0001obtained abs = 1.94376; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00290193; expected ratio = 1e-07obtained abs = 5.7985e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00208575; expected ratio = 0.0001obtained abs = 0.532368; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00102276; expected ratio = 1e-07obtained abs = 2.04207e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000696659; expected ratio = 0.0001obtained abs = 0.177813; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.025990e+05 Mflops = 9.08 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000528564; expected ratio = 1e-07obtained abs = 1.0551e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000354704; expected ratio = 0.0001obtained abs = 0.0905271; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.025990e+05 Mflops = 6.05 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000353779; expected ratio = 1e-07obtained abs = 7.06147e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000250666; expected ratio = 0.0001obtained abs = 0.0639699; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000257492; expected ratio = 1e-07obtained abs = 5.1394e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000195803; expected ratio = 0.0001obtained abs = 0.0499659; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000193649; expected ratio = 1e-07obtained abs = 3.86508e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000157098; expected ratio = 0.0001obtained abs = 0.0400868; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 3.030430e+05 Mflops = 18.18 -Solve time = 0.02 -Solve flops = 2.336400e+04 Mflops = 1.40 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000149054; expected ratio = 1e-07obtained abs = 2.97498e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000127585; expected ratio = 0.0001obtained abs = 0.0325548; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 3.030430e+05 Mflops = 6.06 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000117142; expected ratio = 1e-07obtained abs = 2.33802e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000104533; expected ratio = 0.0001obtained abs = 0.026672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553131 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.38371e-05; expected ratio = 1e-07obtained abs = 1.87288e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.62972e-05; expected ratio = 0.0001obtained abs = 0.0220184; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.64744e-05; expected ratio = 1e-07obtained abs = 1.52634e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.17351e-05; expected ratio = 0.0001obtained abs = 0.0183025; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549793 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.336400e+04 Mflops = 1.40 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 6.32798e-05; expected ratio = 1e-07obtained abs = 1.26298e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.00177e-05; expected ratio = 0.0001obtained abs = 0.0153127; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 3.030430e+05 Mflops = 9.09 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.30599e-05; expected ratio = 1e-07obtained abs = 1.05901e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.05279e-05; expected ratio = 0.0001obtained abs = 0.0128913; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.50023e-05; expected ratio = 1e-07obtained abs = 8.98185e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.27976e-05; expected ratio = 0.0001obtained abs = 0.0109189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.83 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.83 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000672102 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.666130e+05 Mflops = 8.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.209678; expected ratio = 1e-07obtained abs = 0.000346064; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0505647; expected ratio = 0.0001obtained abs = 12.7643; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552177 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0551022; expected ratio = 1e-07obtained abs = 8.6208e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0359786; expected ratio = 0.0001obtained abs = 9.12415; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.017725; expected ratio = 1e-07obtained abs = 2.72525e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0102703; expected ratio = 0.0001obtained abs = 2.60984; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00604008; expected ratio = 1e-07obtained abs = 9.23244e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00330312; expected ratio = 0.0001obtained abs = 0.84006; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00217345; expected ratio = 1e-07obtained abs = 3.31555e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00114811; expected ratio = 0.0001obtained abs = 0.292101; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000884902; expected ratio = 1e-07obtained abs = 1.34897e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000496888; expected ratio = 0.0001obtained abs = 0.126442; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000457914; expected ratio = 1e-07obtained abs = 6.97892e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000317163; expected ratio = 0.0001obtained abs = 0.0807173; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000299688; expected ratio = 1e-07obtained abs = 4.56708e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000250778; expected ratio = 0.0001obtained abs = 0.0638276; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000561953 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000220675; expected ratio = 1e-07obtained abs = 3.36287e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000207716; expected ratio = 0.0001obtained abs = 0.0528706; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000864983 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00017018; expected ratio = 1e-07obtained abs = 2.59335e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000173277; expected ratio = 0.0001obtained abs = 0.0441069; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000134185; expected ratio = 1e-07obtained abs = 2.04482e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000144888; expected ratio = 0.0001obtained abs = 0.0368819; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000107364; expected ratio = 1e-07obtained abs = 1.6361e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000121459; expected ratio = 0.0001obtained abs = 0.030919; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000562191 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.69162e-05; expected ratio = 1e-07obtained abs = 1.3245e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000102122; expected ratio = 0.0001obtained abs = 0.0259972; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.10852e-05; expected ratio = 1e-07obtained abs = 1.08325e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.61327e-05; expected ratio = 0.0001obtained abs = 0.0219273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 5.86788e-05; expected ratio = 1e-07obtained abs = 8.94195e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.28735e-05; expected ratio = 0.0001obtained abs = 0.0185522; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.84 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.84 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558138 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.258472; expected ratio = 1e-07obtained abs = 0.000313056; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0602813; expected ratio = 0.0001obtained abs = 15.2023; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0852578; expected ratio = 1e-07obtained abs = 9.5156e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0376707; expected ratio = 0.0001obtained abs = 9.56198; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.034306; expected ratio = 1e-07obtained abs = 3.70217e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0129927; expected ratio = 0.0001obtained abs = 3.30713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000565052 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0146385; expected ratio = 1e-07obtained abs = 1.55704e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00515392; expected ratio = 0.0001obtained abs = 1.3134; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00641826; expected ratio = 1e-07obtained abs = 6.78372e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00214111; expected ratio = 0.0001obtained abs = 0.545897; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00287096; expected ratio = 1e-07obtained abs = 3.02593e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000930405; expected ratio = 0.0001obtained abs = 0.237259; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00132458; expected ratio = 1e-07obtained abs = 1.39433e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000455914; expected ratio = 0.0001obtained abs = 0.116268; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000654655; expected ratio = 1e-07obtained abs = 6.88742e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000281987; expected ratio = 0.0001obtained abs = 0.0719125; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000569105 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000369508; expected ratio = 1e-07obtained abs = 3.8865e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000212121; expected ratio = 0.0001obtained abs = 0.0540941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000245901; expected ratio = 1e-07obtained abs = 2.58609e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000171673; expected ratio = 0.0001obtained abs = 0.0437781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000184333; expected ratio = 1e-07obtained abs = 1.93849e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000141043; expected ratio = 0.0001obtained abs = 0.0359665; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000146313; expected ratio = 1e-07obtained abs = 1.53863e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000116043; expected ratio = 0.0001obtained abs = 0.0295908; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000118902; expected ratio = 1e-07obtained abs = 1.25035e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.55005e-05; expected ratio = 0.0001obtained abs = 0.0243521; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 9.76646e-05; expected ratio = 1e-07obtained abs = 1.02702e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.87026e-05; expected ratio = 0.0001obtained abs = 0.0200685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 8.07378e-05; expected ratio = 1e-07obtained abs = 8.49018e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.50183e-05; expected ratio = 0.0001obtained abs = 0.0165789; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.85 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.85 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000558853 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.337023; expected ratio = 1e-07obtained abs = 0.000265146; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.07234; expected ratio = 0.0001obtained abs = 18.2238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00056982 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.143738; expected ratio = 1e-07obtained abs = 9.88799e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0373433; expected ratio = 0.0001obtained abs = 9.47585; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000561953 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0744312; expected ratio = 1e-07obtained abs = 4.76612e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.016092; expected ratio = 0.0001obtained abs = 4.09816; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557184 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0413922; expected ratio = 1e-07obtained abs = 2.54545e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00814681; expected ratio = 0.0001obtained abs = 2.07891; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0238885; expected ratio = 1e-07obtained abs = 1.43492e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00439927; expected ratio = 0.0001obtained abs = 1.12391; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00125694 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.014093; expected ratio = 1e-07obtained abs = 8.34842e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00247531; expected ratio = 0.0001obtained abs = 0.632813; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00843782; expected ratio = 1e-07obtained abs = 4.95697e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00144007; expected ratio = 0.0001obtained abs = 0.368301; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555992 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0051107; expected ratio = 1e-07obtained abs = 2.98735e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000868081; expected ratio = 0.0001obtained abs = 0.222066; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00312938; expected ratio = 1e-07obtained abs = 1.82364e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00054693; expected ratio = 0.0001obtained abs = 0.139931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00193962; expected ratio = 1e-07obtained abs = 1.1282e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000363763; expected ratio = 0.0001obtained abs = 0.0930759; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00122073; expected ratio = 1e-07obtained abs = 7.09236e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000256349; expected ratio = 0.0001obtained abs = 0.0655952; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00078405; expected ratio = 1e-07obtained abs = 4.55203e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000190181; expected ratio = 0.0001obtained abs = 0.0486653; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000553846 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000517277; expected ratio = 1e-07obtained abs = 3.00187e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000146617; expected ratio = 0.0001obtained abs = 0.0375183; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000352961; expected ratio = 1e-07obtained abs = 2.04773e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000115938; expected ratio = 0.0001obtained abs = 0.0296683; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.659770e+05 Mflops = 15.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000250324; expected ratio = 1e-07obtained abs = 1.45202e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.31447e-05; expected ratio = 0.0001obtained abs = 0.0238356; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000699043 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000184693; expected ratio = 1e-07obtained abs = 1.0712e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.55849e-05; expected ratio = 0.0001obtained abs = 0.0193422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00077796 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000141254; expected ratio = 1e-07obtained abs = 8.19196e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.17505e-05; expected ratio = 0.0001obtained abs = 0.015802; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.86 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.86 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.479353; expected ratio = 1e-07obtained abs = 0.000188009; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0945785; expected ratio = 0.0001obtained abs = 23.8569; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.276519; expected ratio = 1e-07obtained abs = 8.49849e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0308112; expected ratio = 0.0001obtained abs = 7.83084; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.187928; expected ratio = 1e-07obtained abs = 4.86449e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0167068; expected ratio = 0.0001obtained abs = 4.26419; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.13748; expected ratio = 1e-07obtained abs = 3.13058e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.010309; expected ratio = 0.0001obtained abs = 2.63967; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.659770e+05 Mflops = 5.32 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.104983; expected ratio = 1e-07obtained abs = 2.16509e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00706341; expected ratio = 0.0001obtained abs = 1.81322; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0824768; expected ratio = 1e-07obtained abs = 1.57261e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00520731; expected ratio = 0.0001obtained abs = 1.33951; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0661077; expected ratio = 1e-07obtained abs = 1.18331e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0040288; expected ratio = 0.0001obtained abs = 1.03813; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.228600e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0537765; expected ratio = 1e-07obtained abs = 9.14199e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0032154; expected ratio = 0.0001obtained abs = 0.829707; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000576019 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.659770e+05 Mflops = 7.98 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0446227; expected ratio = 1e-07obtained abs = 7.26756e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00450709; expected ratio = 0.0001obtained abs = 1.16479; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0369133; expected ratio = 1e-07obtained abs = 5.80224e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00218068; expected ratio = 0.0001obtained abs = 0.564148; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0308253; expected ratio = 1e-07obtained abs = 4.70358e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0018265; expected ratio = 0.0001obtained abs = 0.472921; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0258954; expected ratio = 1e-07obtained abs = 3.85395e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00153189; expected ratio = 0.0001obtained abs = 0.396926; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.656890e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0218527; expected ratio = 1e-07obtained abs = 3.18449e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00129167; expected ratio = 0.0001obtained abs = 0.33489; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0185082; expected ratio = 1e-07obtained abs = 2.64941e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00109401; expected ratio = 0.0001obtained abs = 0.283792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.015722; expected ratio = 1e-07obtained abs = 2.2167e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000929816; expected ratio = 0.0001obtained abs = 0.241308; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0133876; expected ratio = 1e-07obtained abs = 1.86334e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000792372; expected ratio = 0.0001obtained abs = 0.205718; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0114224; expected ratio = 1e-07obtained abs = 1.57239e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000676631; expected ratio = 0.0001obtained abs = 0.175727; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00976159; expected ratio = 1e-07obtained abs = 1.33118e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000578722; expected ratio = 0.0001obtained abs = 0.150342; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00835352; expected ratio = 1e-07obtained abs = 1.13001e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000495609; expected ratio = 0.0001obtained abs = 0.128782; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000549078 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00715652; expected ratio = 1e-07obtained abs = 9.61431e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000424865; expected ratio = 0.0001obtained abs = 0.110422; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000548124 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0061367; expected ratio = 1e-07obtained abs = 8.19558e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000364518; expected ratio = 0.0001obtained abs = 0.0947549; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.227400e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00526624; expected ratio = 1e-07obtained abs = 6.99744e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000312953; expected ratio = 0.0001obtained abs = 0.0813632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00452213; expected ratio = 1e-07obtained abs = 5.98255e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00026883; expected ratio = 0.0001obtained abs = 0.0699012; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000547886 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00388522; expected ratio = 1e-07obtained abs = 5.12072e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000231033; expected ratio = 0.0001obtained abs = 0.06008; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00333949; expected ratio = 1e-07obtained abs = 4.38729e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000198625; expected ratio = 0.0001obtained abs = 0.0516573; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.656890e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00287148; expected ratio = 1e-07obtained abs = 3.76199e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000170817; expected ratio = 0.0001obtained abs = 0.0444288; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000551939 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00246982; expected ratio = 1e-07obtained abs = 3.22807e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00014694; expected ratio = 0.0001obtained abs = 0.0382213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00212489; expected ratio = 1e-07obtained abs = 2.77155e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000126429; expected ratio = 0.0001obtained abs = 0.032888; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00182853; expected ratio = 1e-07obtained abs = 2.3808e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000108801; expected ratio = 0.0001obtained abs = 0.0283039; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00054884 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655330e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00157379; expected ratio = 1e-07obtained abs = 2.04601e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.3645e-05; expected ratio = 0.0001obtained abs = 0.0243624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000555038 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00135474; expected ratio = 1e-07obtained abs = 1.75894e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.06113e-05; expected ratio = 0.0001obtained abs = 0.0209724; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000552893 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00116634; expected ratio = 1e-07obtained abs = 1.51262e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 6.93996e-05; expected ratio = 0.0001obtained abs = 0.0180561; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.00056982 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00100424; expected ratio = 1e-07obtained abs = 1.30113e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.97529e-05; expected ratio = 0.0001obtained abs = 0.0155467; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655330e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00086475; expected ratio = 1e-07obtained abs = 1.11947e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.14514e-05; expected ratio = 0.0001obtained abs = 0.0133871; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000568151 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655330e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000744692; expected ratio = 1e-07obtained abs = 9.63353e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 4.43064e-05; expected ratio = 0.0001obtained abs = 0.0115283; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.87 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.87 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000554085 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655330e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.686003; expected ratio = 1e-07obtained abs = 5.27592e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.121806; expected ratio = 0.0001obtained abs = 31.0969; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000576973 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.492299; expected ratio = 1e-07obtained abs = 2.54953e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0140715; expected ratio = 0.0001obtained abs = 3.61825; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550032 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.341288; expected ratio = 1e-07obtained abs = 1.3263e-05; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0142153; expected ratio = 0.0001obtained abs = 3.67679; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.266419; expected ratio = 1e-07obtained abs = 8.20161e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0133973; expected ratio = 0.0001obtained abs = 3.47902; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000539064 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655510e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.185683; expected ratio = 1e-07obtained abs = 4.84181e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00987867; expected ratio = 0.0001obtained abs = 2.57511; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655330e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0984862; expected ratio = 1e-07obtained abs = 2.35238e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0110378; expected ratio = 0.0001obtained abs = 2.87701; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000540018 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0502969; expected ratio = 1e-07obtained abs = 1.14825e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0063797; expected ratio = 0.0001obtained abs = 1.66504; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000536919 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0193803; expected ratio = 1e-07obtained abs = 4.34936e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00326747; expected ratio = 0.0001obtained abs = 0.853627; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000539064 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.654150e+05 Mflops = 15.92 -Solve time = 0.02 -Solve flops = 2.225600e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00669953; expected ratio = 1e-07obtained abs = 1.49436e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00111293; expected ratio = 0.0001obtained abs = 0.290916; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000538826 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.654150e+05 Mflops = 7.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00252076; expected ratio = 1e-07obtained abs = 5.60982e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000425314; expected ratio = 0.0001obtained abs = 0.1112; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.88 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.88 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.653950e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.145589; expected ratio = 1e-07obtained abs = 3.76293e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0401793; expected ratio = 0.0001obtained abs = 10.5726; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000540018 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.654150e+05 Mflops = 7.96 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0560639; expected ratio = 1e-07obtained abs = 1.52635e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0119746; expected ratio = 0.0001obtained abs = 3.14367; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000538826 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0285828; expected ratio = 1e-07obtained abs = 7.98791e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00521839; expected ratio = 0.0001obtained abs = 1.36937; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000535965 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0167856; expected ratio = 1e-07obtained abs = 4.76149e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00310829; expected ratio = 0.0001obtained abs = 0.815613; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000536919 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00749561; expected ratio = 1e-07obtained abs = 2.1409e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00132722; expected ratio = 0.0001obtained abs = 0.348168; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000539064 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655330e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00895925; expected ratio = 1e-07obtained abs = 2.57746e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00300073; expected ratio = 0.0001obtained abs = 0.787941; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000539064 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00415465; expected ratio = 1e-07obtained abs = 1.19966e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000788494; expected ratio = 0.0001obtained abs = 0.207076; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000537872 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00202022; expected ratio = 1e-07obtained abs = 5.84413e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000338992; expected ratio = 0.0001obtained abs = 0.0890265; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.89 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.89 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0856961; expected ratio = 1e-07obtained abs = 2.2925e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0204922; expected ratio = 0.0001obtained abs = 5.35931; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000539064 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0273766; expected ratio = 1e-07obtained abs = 7.14418e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00458183; expected ratio = 0.0001obtained abs = 1.19988; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000550985 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0118723; expected ratio = 1e-07obtained abs = 3.06476e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00195919; expected ratio = 0.0001obtained abs = 0.513378; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000560999 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00988574; expected ratio = 1e-07obtained abs = 2.531e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00252638; expected ratio = 0.0001obtained abs = 0.661562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000540018 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.008023; expected ratio = 1e-07obtained abs = 2.04157e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00189938; expected ratio = 0.0001obtained abs = 0.49721; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000536919 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00260319; expected ratio = 1e-07obtained abs = 6.60873e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00043759; expected ratio = 0.0001obtained abs = 0.114562; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.9 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.9 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543833 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0448081; expected ratio = 1e-07obtained abs = 1.18711e-06; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.0115464; expected ratio = 0.0001obtained abs = 3.02975; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000540018 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.013447; expected ratio = 1e-07obtained abs = 3.60692e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00262845; expected ratio = 0.0001obtained abs = 0.689066; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000536919 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00573108; expected ratio = 1e-07obtained abs = 1.54539e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00109284; expected ratio = 0.0001obtained abs = 0.286385; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000561953 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0024818; expected ratio = 1e-07obtained abs = 6.7075e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00046787; expected ratio = 0.0001obtained abs = 0.122586; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.91 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.91 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0262012; expected ratio = 1e-07obtained abs = 6.91424e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00673473; expected ratio = 0.0001obtained abs = 1.76212; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000540018 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00775671; expected ratio = 1e-07obtained abs = 2.03259e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00150275; expected ratio = 0.0001obtained abs = 0.393393; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000546217 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00323848; expected ratio = 1e-07obtained abs = 8.46119e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000609782; expected ratio = 0.0001obtained abs = 0.159664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.92 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.92 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0143629; expected ratio = 1e-07obtained abs = 3.80197e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00395756; expected ratio = 0.0001obtained abs = 1.03713; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000541925 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00416461; expected ratio = 1e-07obtained abs = 1.10657e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000842215; expected ratio = 0.0001obtained abs = 0.220652; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000539064 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00175402; expected ratio = 1e-07obtained abs = 4.66804e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000340524; expected ratio = 0.0001obtained abs = 0.0892034; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.93 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.93 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00861528; expected ratio = 1e-07obtained abs = 2.27532e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00233436; expected ratio = 0.0001obtained abs = 0.611192; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000537157 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.0025; expected ratio = 1e-07obtained abs = 6.58775e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000509505; expected ratio = 0.0001obtained abs = 0.133423; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.94 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.94 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543833 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00454228; expected ratio = 1e-07obtained abs = 1.20166e-07; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.00141914; expected ratio = 0.0001obtained abs = 0.371756; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000537157 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00123102; expected ratio = 1e-07obtained abs = 3.26023e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000262091; expected ratio = 0.0001obtained abs = 0.068651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.95 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.95 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00288522; expected ratio = 1e-07obtained abs = 7.62231e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000851342; expected ratio = 0.0001obtained abs = 0.222951; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.96 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.96 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00132235; expected ratio = 1e-07obtained abs = 3.49718e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000556731; expected ratio = 0.0001obtained abs = 0.14582; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.97 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.97 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000563145 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.00104227; expected ratio = 1e-07obtained abs = 2.75405e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000332136; expected ratio = 0.0001obtained abs = 0.0869859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.98 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.98 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000563145 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000545636; expected ratio = 1e-07obtained abs = 1.44238e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000216045; expected ratio = 0.0001obtained abs = 0.0565853; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -0.99 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 0.99 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542164 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000402073; expected ratio = 1e-07obtained abs = 1.06252e-08; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 0.000130311; expected ratio = 0.0001obtained abs = 0.0341287; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.0 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000212558; expected ratio = 1e-07obtained abs = 5.61795e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.5309e-05; expected ratio = 0.0001obtained abs = 0.0223432; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -line49 -Estimating delta time -1.01 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.01 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 0.000164901; expected ratio = 1e-07obtained abs = 4.35777e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 5.10174e-05; expected ratio = 0.0001obtained abs = 0.0133616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.02 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.02 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.77724e-05; expected ratio = 1e-07obtained abs = 2.05537e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 3.4953e-05; expected ratio = 0.0001obtained abs = 0.00915437; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.03 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.03 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 7.48127e-05; expected ratio = 1e-07obtained abs = 1.97703e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 2.0476e-05; expected ratio = 0.0001obtained abs = 0.00536273; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.04 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.04 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.74368e-05; expected ratio = 1e-07obtained abs = 7.25062e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 1.61066e-05; expected ratio = 0.0001obtained abs = 0.00421838; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.05 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.05 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000571012 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 4.09162e-05; expected ratio = 1e-07obtained abs = 1.08124e-09; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.97371e-06; expected ratio = 0.0001obtained abs = 0.00261213; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.06 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.06 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.70324e-05; expected ratio = 1e-07obtained abs = 4.5009e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 9.86017e-06; expected ratio = 0.0001obtained abs = 0.00258238; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.07 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.07 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.87241e-05; expected ratio = 1e-07obtained abs = 7.59033e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.59279e-06; expected ratio = 0.0001obtained abs = 0.00198855; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.08 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.08 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 1.90593e-05; expected ratio = 1e-07obtained abs = 5.03633e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 8.16075e-06; expected ratio = 0.0001obtained abs = 0.00213729; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.09 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.09 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542879 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.4482e-05; expected ratio = 1e-07obtained abs = 6.46914e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.37574e-06; expected ratio = 0.0001obtained abs = 0.00193169; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.1 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.1 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000541925 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.07762e-05; expected ratio = 1e-07obtained abs = 5.48982e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.72187e-06; expected ratio = 0.0001obtained abs = 0.00202233; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.11 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.11 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2977e-05; expected ratio = 1e-07obtained abs = 6.07125e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.43255e-06; expected ratio = 0.0001obtained abs = 0.00194655; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.12 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.12 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.15533e-05; expected ratio = 1e-07obtained abs = 5.69495e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.59213e-06; expected ratio = 0.0001obtained abs = 0.00198834; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.13 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.13 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.24214e-05; expected ratio = 1e-07obtained abs = 5.92423e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.47853e-06; expected ratio = 0.0001obtained abs = 0.00195858; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.14 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.14 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.18704e-05; expected ratio = 1e-07obtained abs = 5.77853e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.54701e-06; expected ratio = 0.0001obtained abs = 0.00197651; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.15 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.15 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.22099e-05; expected ratio = 1e-07obtained abs = 5.86815e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50076e-06; expected ratio = 0.0001obtained abs = 0.00196439; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.16 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.16 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.19954e-05; expected ratio = 1e-07obtained abs = 5.81137e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.52945e-06; expected ratio = 0.0001obtained abs = 0.00197189; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.17 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.17 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542164 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.21276e-05; expected ratio = 1e-07obtained abs = 5.84621e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51021e-06; expected ratio = 0.0001obtained abs = 0.00196685; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.18 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.18 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542164 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20436e-05; expected ratio = 1e-07obtained abs = 5.82391e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.52208e-06; expected ratio = 0.0001obtained abs = 0.00196995; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.19 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.19 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543833 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20949e-05; expected ratio = 1e-07obtained abs = 5.83735e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51392e-06; expected ratio = 0.0001obtained abs = 0.0019678; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.2 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.2 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543833 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20617e-05; expected ratio = 1e-07obtained abs = 5.82847e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51873e-06; expected ratio = 0.0001obtained abs = 0.00196906; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.21 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.21 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20813e-05; expected ratio = 1e-07obtained abs = 5.83354e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51515e-06; expected ratio = 0.0001obtained abs = 0.00196811; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.22 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.22 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000542164 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20679e-05; expected ratio = 1e-07obtained abs = 5.8299e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51702e-06; expected ratio = 0.0001obtained abs = 0.00196859; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.23 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.23 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20751e-05; expected ratio = 1e-07obtained abs = 5.83171e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51536e-06; expected ratio = 0.0001obtained abs = 0.00196815; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.24 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.24 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20694e-05; expected ratio = 1e-07obtained abs = 5.83011e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51598e-06; expected ratio = 0.0001obtained abs = 0.00196831; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.25 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.25 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20718e-05; expected ratio = 1e-07obtained abs = 5.83064e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51513e-06; expected ratio = 0.0001obtained abs = 0.00196808; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.26 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.26 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20692e-05; expected ratio = 1e-07obtained abs = 5.82984e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51523e-06; expected ratio = 0.0001obtained abs = 0.0019681; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.27 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.27 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000546217 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20697e-05; expected ratio = 1e-07obtained abs = 5.82987e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51471e-06; expected ratio = 0.0001obtained abs = 0.00196795; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.28 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.28 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543118 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.02 -Solve flops = 2.226200e+04 Mflops = 1.34 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20682e-05; expected ratio = 1e-07obtained abs = 5.82938e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.5146e-06; expected ratio = 0.0001obtained abs = 0.00196792; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.29 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.29 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2068e-05; expected ratio = 1e-07obtained abs = 5.82922e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51422e-06; expected ratio = 0.0001obtained abs = 0.00196781; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.3 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.3 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2067e-05; expected ratio = 1e-07obtained abs = 5.82885e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51402e-06; expected ratio = 0.0001obtained abs = 0.00196775; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.31 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.31 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20664e-05; expected ratio = 1e-07obtained abs = 5.82861e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.5137e-06; expected ratio = 0.0001obtained abs = 0.00196766; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.32 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.32 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000546932 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20656e-05; expected ratio = 1e-07obtained abs = 5.82829e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51345e-06; expected ratio = 0.0001obtained abs = 0.00196759; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.33 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.33 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000602961 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2065e-05; expected ratio = 1e-07obtained abs = 5.82802e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51316e-06; expected ratio = 0.0001obtained abs = 0.0019675; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.34 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.34 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.02 -Factor flops = 2.655530e+05 Mflops = 15.93 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20642e-05; expected ratio = 1e-07obtained abs = 5.82772e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.5129e-06; expected ratio = 0.0001obtained abs = 0.00196743; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.35 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.35 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543833 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20635e-05; expected ratio = 1e-07obtained abs = 5.82744e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51262e-06; expected ratio = 0.0001obtained abs = 0.00196735; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.36 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.36 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20628e-05; expected ratio = 1e-07obtained abs = 5.82714e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51235e-06; expected ratio = 0.0001obtained abs = 0.00196727; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.37 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.37 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000541925 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20621e-05; expected ratio = 1e-07obtained abs = 5.82686e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51208e-06; expected ratio = 0.0001obtained abs = 0.00196719; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.38 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.38 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000683069 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20614e-05; expected ratio = 1e-07obtained abs = 5.82656e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51181e-06; expected ratio = 0.0001obtained abs = 0.00196711; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.39 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.39 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545979 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20607e-05; expected ratio = 1e-07obtained abs = 5.82628e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51153e-06; expected ratio = 0.0001obtained abs = 0.00196703; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.4 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.4 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.206e-05; expected ratio = 1e-07obtained abs = 5.82599e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51126e-06; expected ratio = 0.0001obtained abs = 0.00196695; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.41 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.02"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.41 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20593e-05; expected ratio = 1e-07obtained abs = 5.8257e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51099e-06; expected ratio = 0.0001obtained abs = 0.00196687; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.42 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.42 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20586e-05; expected ratio = 1e-07obtained abs = 5.82541e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51071e-06; expected ratio = 0.0001obtained abs = 0.00196679; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.43 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.43 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000557899 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20579e-05; expected ratio = 1e-07obtained abs = 5.82512e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51044e-06; expected ratio = 0.0001obtained abs = 0.00196672; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.44 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.44 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000565052 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20571e-05; expected ratio = 1e-07obtained abs = 5.82483e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.51017e-06; expected ratio = 0.0001obtained abs = 0.00196664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.45 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.45 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20564e-05; expected ratio = 1e-07obtained abs = 5.82454e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50989e-06; expected ratio = 0.0001obtained abs = 0.00196656; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.46 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.46 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000544071 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20557e-05; expected ratio = 1e-07obtained abs = 5.82425e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50962e-06; expected ratio = 0.0001obtained abs = 0.00196648; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.47 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.47 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000540972 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.2055e-05; expected ratio = 1e-07obtained abs = 5.82397e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50935e-06; expected ratio = 0.0001obtained abs = 0.0019664; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.48 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0.01"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.48 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000545025 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.00 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20543e-05; expected ratio = 1e-07obtained abs = 5.82368e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50908e-06; expected ratio = 0.0001obtained abs = 0.00196632; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.49 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.49 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000556946 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.03 -Factor flops = 2.655530e+05 Mflops = 7.97 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20536e-05; expected ratio = 1e-07obtained abs = 5.82339e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.5088e-06; expected ratio = 0.0001obtained abs = 0.00196624; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -line49 -Estimating delta time -1.5 -143 -"Trigen PFEM Refining Mesher" : Trigen PFEM Refining Mesher -"Number of nodes after erasing" : Number of nodes after erasing -ThisModelPart.Nodes().size() : 126 -Constructing Delaunay triangulation by divide-and-conquer method. -Delaunay milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing edges. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - - Mesh vertices: 126 - Mesh triangles: 195 - Mesh edges: 320 - Mesh exterior boundary edges: 55 - -mesh generation time = 0"ln367" : ln367 -el_number : 195 -"ln420" : ln420 -Reconstructing mesh. -Mesh reconstruction milliseconds: 0 -Adding Steiner points to enforce quality. -Quality milliseconds: 0 - -Writing vertices. -Writing triangles. -Writing neighbors. - -Output milliseconds: 0 -Total running milliseconds: 0 - -Statistics: - - Input vertices: 126 - Input triangles: 149 - - Mesh vertices: 126 - Mesh triangles: 149 - Mesh edges: 241 - Mesh exterior boundary edges: 35 - Mesh interior boundary edges: 0 - Mesh subsegments (constrained edges): 35 - -"Adaptive remeshing executed" : Adaptive remeshing executed -"ln449" : ln449 -During refinement we added 0 nodes -"ln749" : ln749 -"ln752" : ln752 -"ln754" : ln754 -"Finished remeshing with Trigen_PFEM_Refine" : Finished remeshing with Trigen_PFEM_Refine -regenerated mesh -found neighbours -number of connected components1 -applied BC -145 -"setting up the dofs" : setting up the dofs -"finished setting up the dofs" : finished setting up the dofs - -CurrentTime = 1.5 -matrix_partition : [9](0,29,58,87,116,145,174,203,235) -prediction -end of prediction -number_of_threads : 8 -element_partition : [9](0,18,36,54,72,90,108,126,149) -time: 0.000543833 -"finished parallel building" : finished parallel building -matrix size in solver: 235 -RHS size in solver: 235 -I am here - - -Matrix storage type: 0 -Factor time = 0.05 -Factor flops = 2.655530e+05 Mflops = 5.31 -Solve time = 0.00 -SuperLU solver finished. - -VELOCITY CRITERIA :: obtained ratio = 2.20529e-05; expected ratio = 1e-07obtained abs = 5.8231e-10; expected abs = 1e-07 -PRESSURE CRITERIA :: obtained ratio = 7.50853e-06; expected ratio = 0.0001obtained abs = 0.00196616; expected abs = 1e-07 -AIR_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -WATER_PRESSURE CRITERIA :: obtained ratio = 0; expected ratio = 0.0001obtained abs = 0; expected abs = 1e-07 -"convergence is achieved" : convergence is achieved -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -KKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKKK -"in MoveLonelyNodes" : in MoveLonelyNodes -a47 -Newton Raphson strategy Clear function used -"ResidualBasedEliminationBuilderAndSolver Clear Function called" : ResidualBasedEliminationBuilderAndSolver Clear Function called -149 -"writing Node Mesh" : writing Node Mesh -writing a 2D mesh -solution finished *********************** diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/pfem_nonewtonian_var.py b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/pfem_nonewtonian_var.py deleted file mode 100644 index c1d6c1ccf1fb..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/pfem_nonewtonian_var.py +++ /dev/null @@ -1,29 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -domain_size = 2 - -Density = 1000.0 -Viscosity = 0.000001 -Gravity_X = 0.0 -Gravity_Y = -9.806 -Gravity_Z = 0.0 -YieldStress = 1500.0 -max_x = 2.5 -max_y = 3.0 -max_z = 1.0 -min_x = -1.0 -min_y = -1.0 -min_z = -1.0 -use_oss = 0 -dynamic_tau = 1 -nsteps = 150 -output_Dt = 0.5 -min_dt = 0.01 -max_dt = 0.1 -safety_factor = 0.1 -SolverType = "monolithic_solver_lagrangian" -laplacian_form = 3 -# Declare Python Variables - -problem_name = "dam2dNonNewt_Y1500" -problem_path = "/home/antonia/kratos/applications/PFEMapplication/test_exemples/dam2dNonNewt_Y1500.gid" -kratos_path = "/home/antonia/kratos" diff --git a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/pfem_nonewtonian_var_benchmark.py b/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/pfem_nonewtonian_var_benchmark.py deleted file mode 100644 index c1d6c1ccf1fb..000000000000 --- a/applications/PFEMapplication/test_examples/dam2dNonNewt_Y1500.gid/pfem_nonewtonian_var_benchmark.py +++ /dev/null @@ -1,29 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -domain_size = 2 - -Density = 1000.0 -Viscosity = 0.000001 -Gravity_X = 0.0 -Gravity_Y = -9.806 -Gravity_Z = 0.0 -YieldStress = 1500.0 -max_x = 2.5 -max_y = 3.0 -max_z = 1.0 -min_x = -1.0 -min_y = -1.0 -min_z = -1.0 -use_oss = 0 -dynamic_tau = 1 -nsteps = 150 -output_Dt = 0.5 -min_dt = 0.01 -max_dt = 0.1 -safety_factor = 0.1 -SolverType = "monolithic_solver_lagrangian" -laplacian_form = 3 -# Declare Python Variables - -problem_name = "dam2dNonNewt_Y1500" -problem_path = "/home/antonia/kratos/applications/PFEMapplication/test_exemples/dam2dNonNewt_Y1500.gid" -kratos_path = "/home/antonia/kratos" diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.cnd b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.cnd deleted file mode 100644 index c2b01f166aad..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.cnd +++ /dev/null @@ -1,458 +0,0 @@ -BOOK:Fluid_Boundary_Conditions -NUMBER: 1 CONDITION: point_BODY_FORCE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 2 CONDITION: line_BODY_FORCE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 3 CONDITION: surface_BODY_FORCE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 4 CONDITION: volume_BODY_FORCE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 5 CONDITION: point_VELOCITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 6 CONDITION: line_VELOCITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 7 CONDITION: surface_VELOCITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 8 CONDITION: volume_VELOCITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 9 CONDITION: point_DISPLACEMENT_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 10 CONDITION: line_DISPLACEMENT_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 11 CONDITION: surface_DISPLACEMENT_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 12 CONDITION: volume_DISPLACEMENT_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 13 CONDITION: point_HEAT_FLUX_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 14 CONDITION: line_HEAT_FLUX_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 15 CONDITION: surface_HEAT_FLUX_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 16 CONDITION: volume_HEAT_FLUX_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 17 CONDITION: point_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 18 CONDITION: line_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 19 CONDITION: surface_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 20 CONDITION: volume_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 21 CONDITION: point_CONDUCTIVITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 22 CONDITION: line_CONDUCTIVITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 23 CONDITION: surface_CONDUCTIVITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 24 CONDITION: volume_CONDUCTIVITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 25 CONDITION: point_TEMPERATURE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 26 CONDITION: line_TEMPERATURE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 27 CONDITION: surface_TEMPERATURE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 28 CONDITION: volume_TEMPERATURE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 29 CONDITION: point_IS_STRUCTURE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 30 CONDITION: line_IS_STRUCTURE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 31 CONDITION: surface_IS_STRUCTURE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 32 CONDITION: volume_IS_STRUCTURE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 33 CONDITION: point_DENSITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 34 CONDITION: line_DENSITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 35 CONDITION: surface_DENSITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 36 CONDITION: volume_DENSITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 37 CONDITION: point_VISCOSITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 38 CONDITION: line_VISCOSITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 39 CONDITION: surface_VISCOSITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 40 CONDITION: volume_VISCOSITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 41 CONDITION: point_PRESSURE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 42 CONDITION: line_PRESSURE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 43 CONDITION: surface_PRESSURE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 44 CONDITION: volume_PRESSURE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -BOOK:Fluid_Element_Type -NUMBER: 45 CONDITION: volume_ConvDiff3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(ConvDiff3D) -VALUE: ConvDiff3D -END CONDITION -NUMBER: 46 CONDITION: surface_ConvDiff2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(ConvDiff2D) -VALUE: ConvDiff2D -END CONDITION -NUMBER: 47 CONDITION: volume_Fluid3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Fluid3D) -VALUE: Fluid3D -END CONDITION -NUMBER: 48 CONDITION: surface_Fluid2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Fluid2D) -VALUE: Fluid2D -END CONDITION -NUMBER: 49 CONDITION: surface_Condition3D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Condition3D) -VALUE: Condition3D -END CONDITION -NUMBER: 50 CONDITION: line_Condition2D -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Condition2D) -VALUE: Condition2D -END CONDITION diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.cond b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.cond deleted file mode 100644 index c748bce60b35..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.cond +++ /dev/null @@ -1,21756 +0,0 @@ - - -// Fixing degrees of freedom in nodes - -NODES[1].Fix(IS_STRUCTURE); -NODES[2].Fix(IS_STRUCTURE); -NODES[3].Fix(IS_STRUCTURE); -NODES[4].Fix(IS_STRUCTURE); -NODES[5].Fix(IS_STRUCTURE); -NODES[6].Fix(IS_STRUCTURE); -NODES[7].Fix(IS_STRUCTURE); -NODES[8].Fix(IS_STRUCTURE); -NODES[9].Fix(IS_STRUCTURE); -NODES[10].Fix(IS_STRUCTURE); -NODES[11].Fix(IS_STRUCTURE); -NODES[12].Fix(IS_STRUCTURE); -NODES[13].Fix(IS_STRUCTURE); -NODES[14].Fix(IS_STRUCTURE); -NODES[15].Fix(IS_STRUCTURE); -NODES[16].Fix(IS_STRUCTURE); -NODES[17].Fix(IS_STRUCTURE); -NODES[18].Fix(IS_STRUCTURE); -NODES[19].Fix(IS_STRUCTURE); -NODES[20].Fix(IS_STRUCTURE); -NODES[21].Fix(IS_STRUCTURE); -NODES[22].Fix(IS_STRUCTURE); -NODES[23].Fix(IS_STRUCTURE); -NODES[24].Fix(IS_STRUCTURE); -NODES[25].Fix(IS_STRUCTURE); -NODES[26].Fix(IS_STRUCTURE); -NODES[27].Fix(IS_STRUCTURE); -NODES[28].Fix(IS_STRUCTURE); -NODES[29].Fix(IS_STRUCTURE); -NODES[30].Fix(IS_STRUCTURE); -NODES[31].Fix(IS_STRUCTURE); -NODES[32].Fix(IS_STRUCTURE); -NODES[33].Fix(IS_STRUCTURE); -NODES[34].Fix(IS_STRUCTURE); -NODES[35].Fix(IS_STRUCTURE); -NODES[36].Fix(IS_STRUCTURE); -NODES[37].Fix(IS_STRUCTURE); -NODES[38].Fix(IS_STRUCTURE); -NODES[39].Fix(IS_STRUCTURE); -NODES[40].Fix(IS_STRUCTURE); -NODES[41].Fix(IS_STRUCTURE); -NODES[42].Fix(IS_STRUCTURE); -NODES[43].Fix(IS_STRUCTURE); -NODES[44].Fix(IS_STRUCTURE); -NODES[45].Fix(IS_STRUCTURE); -NODES[46].Fix(IS_STRUCTURE); -NODES[47].Fix(IS_STRUCTURE); -NODES[48].Fix(IS_STRUCTURE); -NODES[49].Fix(IS_STRUCTURE); -NODES[50].Fix(IS_STRUCTURE); -NODES[51].Fix(IS_STRUCTURE); -NODES[52].Fix(IS_STRUCTURE); -NODES[53].Fix(IS_STRUCTURE); -NODES[54].Fix(IS_STRUCTURE); -NODES[55].Fix(IS_STRUCTURE); -NODES[56].Fix(IS_STRUCTURE); -NODES[57].Fix(IS_STRUCTURE); -NODES[58].Fix(IS_STRUCTURE); -NODES[59].Fix(IS_STRUCTURE); -NODES[60].Fix(IS_STRUCTURE); -NODES[61].Fix(IS_STRUCTURE); -NODES[62].Fix(IS_STRUCTURE); -NODES[63].Fix(IS_STRUCTURE); -NODES[64].Fix(IS_STRUCTURE); -NODES[65].Fix(IS_STRUCTURE); -NODES[66].Fix(IS_STRUCTURE); -NODES[67].Fix(IS_STRUCTURE); -NODES[68].Fix(IS_STRUCTURE); -NODES[69].Fix(IS_STRUCTURE); -NODES[70].Fix(IS_STRUCTURE); -NODES[71].Fix(IS_STRUCTURE); -NODES[72].Fix(IS_STRUCTURE); -NODES[73].Fix(IS_STRUCTURE); -NODES[74].Fix(IS_STRUCTURE); -NODES[75].Fix(IS_STRUCTURE); -NODES[76].Fix(IS_STRUCTURE); -NODES[77].Fix(IS_STRUCTURE); -NODES[78].Fix(IS_STRUCTURE); -NODES[79].Fix(IS_STRUCTURE); -NODES[80].Fix(IS_STRUCTURE); -NODES[81].Fix(IS_STRUCTURE); -NODES[82].Fix(IS_STRUCTURE); -NODES[83].Fix(IS_STRUCTURE); -NODES[84].Fix(IS_STRUCTURE); -NODES[85].Fix(IS_STRUCTURE); -NODES[86].Fix(IS_STRUCTURE); -NODES[87].Fix(IS_STRUCTURE); -NODES[88].Fix(IS_STRUCTURE); -NODES[89].Fix(IS_STRUCTURE); -NODES[90].Fix(IS_STRUCTURE); -NODES[91].Fix(IS_STRUCTURE); -NODES[92].Fix(IS_STRUCTURE); -NODES[93].Fix(IS_STRUCTURE); -NODES[94].Fix(IS_STRUCTURE); -NODES[95].Fix(IS_STRUCTURE); -NODES[96].Fix(IS_STRUCTURE); -NODES[97].Fix(IS_STRUCTURE); -NODES[98].Fix(IS_STRUCTURE); -NODES[99].Fix(IS_STRUCTURE); -NODES[100].Fix(IS_STRUCTURE); -NODES[101].Fix(IS_STRUCTURE); -NODES[102].Fix(IS_STRUCTURE); -NODES[103].Fix(IS_STRUCTURE); -NODES[104].Fix(IS_STRUCTURE); -NODES[105].Fix(IS_STRUCTURE); -NODES[106].Fix(IS_STRUCTURE); -NODES[107].Fix(IS_STRUCTURE); -NODES[108].Fix(IS_STRUCTURE); -NODES[109].Fix(IS_STRUCTURE); -NODES[110].Fix(IS_STRUCTURE); -NODES[111].Fix(IS_STRUCTURE); -NODES[112].Fix(IS_STRUCTURE); -NODES[113].Fix(IS_STRUCTURE); -NODES[114].Fix(IS_STRUCTURE); -NODES[115].Fix(IS_STRUCTURE); -NODES[116].Fix(IS_STRUCTURE); -NODES[117].Fix(IS_STRUCTURE); -NODES[118].Fix(IS_STRUCTURE); -NODES[119].Fix(IS_STRUCTURE); -NODES[120].Fix(IS_STRUCTURE); -NODES[121].Fix(IS_STRUCTURE); -NODES[122].Fix(IS_STRUCTURE); -NODES[123].Fix(IS_STRUCTURE); -NODES[124].Fix(IS_STRUCTURE); -NODES[125].Fix(IS_STRUCTURE); -NODES[126].Fix(IS_STRUCTURE); -NODES[127].Fix(IS_STRUCTURE); -NODES[128].Fix(IS_STRUCTURE); -NODES[129].Fix(IS_STRUCTURE); -NODES[130].Fix(IS_STRUCTURE); -NODES[131].Fix(IS_STRUCTURE); -NODES[132].Fix(IS_STRUCTURE); -NODES[133].Fix(IS_STRUCTURE); -NODES[134].Fix(IS_STRUCTURE); -NODES[135].Fix(IS_STRUCTURE); -NODES[136].Fix(IS_STRUCTURE); -NODES[137].Fix(IS_STRUCTURE); -NODES[138].Fix(IS_STRUCTURE); -NODES[139].Fix(IS_STRUCTURE); -NODES[140].Fix(IS_STRUCTURE); -NODES[141].Fix(IS_STRUCTURE); -NODES[142].Fix(IS_STRUCTURE); -NODES[143].Fix(IS_STRUCTURE); -NODES[144].Fix(IS_STRUCTURE); -NODES[145].Fix(IS_STRUCTURE); -NODES[146].Fix(IS_STRUCTURE); -NODES[147].Fix(IS_STRUCTURE); -NODES[148].Fix(IS_STRUCTURE); -NODES[149].Fix(IS_STRUCTURE); -NODES[150].Fix(IS_STRUCTURE); -NODES[151].Fix(IS_STRUCTURE); -NODES[152].Fix(IS_STRUCTURE); -NODES[153].Fix(IS_STRUCTURE); -NODES[154].Fix(IS_STRUCTURE); -NODES[155].Fix(IS_STRUCTURE); -NODES[156].Fix(IS_STRUCTURE); -NODES[157].Fix(IS_STRUCTURE); -NODES[158].Fix(IS_STRUCTURE); -NODES[159].Fix(IS_STRUCTURE); -NODES[160].Fix(IS_STRUCTURE); -NODES[161].Fix(IS_STRUCTURE); -NODES[162].Fix(IS_STRUCTURE); -NODES[163].Fix(IS_STRUCTURE); -NODES[164].Fix(IS_STRUCTURE); -NODES[165].Fix(IS_STRUCTURE); -NODES[166].Fix(IS_STRUCTURE); -NODES[167].Fix(IS_STRUCTURE); -NODES[168].Fix(IS_STRUCTURE); -NODES[169].Fix(IS_STRUCTURE); -NODES[170].Fix(IS_STRUCTURE); -NODES[171].Fix(IS_STRUCTURE); -NODES[172].Fix(IS_STRUCTURE); -NODES[173].Fix(IS_STRUCTURE); -NODES[174].Fix(IS_STRUCTURE); -NODES[175].Fix(IS_STRUCTURE); -NODES[176].Fix(IS_STRUCTURE); -NODES[177].Fix(IS_STRUCTURE); -NODES[178].Fix(IS_STRUCTURE); -NODES[179].Fix(IS_STRUCTURE); -NODES[180].Fix(IS_STRUCTURE); -NODES[181].Fix(IS_STRUCTURE); -NODES[182].Fix(IS_STRUCTURE); -NODES[183].Fix(IS_STRUCTURE); -NODES[184].Fix(IS_STRUCTURE); -NODES[185].Fix(IS_STRUCTURE); -NODES[186].Fix(IS_STRUCTURE); -NODES[187].Fix(IS_STRUCTURE); -NODES[188].Fix(IS_STRUCTURE); -NODES[189].Fix(IS_STRUCTURE); -NODES[190].Fix(IS_STRUCTURE); -NODES[191].Fix(IS_STRUCTURE); -NODES[192].Fix(IS_STRUCTURE); -NODES[193].Fix(IS_STRUCTURE); -NODES[194].Fix(IS_STRUCTURE); -NODES[195].Fix(IS_STRUCTURE); -NODES[196].Fix(IS_STRUCTURE); -NODES[197].Fix(IS_STRUCTURE); -NODES[198].Fix(IS_STRUCTURE); -NODES[199].Fix(IS_STRUCTURE); -NODES[200].Fix(IS_STRUCTURE); -NODES[201].Fix(IS_STRUCTURE); -NODES[202].Fix(IS_STRUCTURE); -NODES[203].Fix(IS_STRUCTURE); -NODES[204].Fix(IS_STRUCTURE); -NODES[205].Fix(IS_STRUCTURE); -NODES[206].Fix(IS_STRUCTURE); -NODES[207].Fix(IS_STRUCTURE); -NODES[208].Fix(IS_STRUCTURE); -NODES[209].Fix(IS_STRUCTURE); -NODES[210].Fix(IS_STRUCTURE); -NODES[211].Fix(IS_STRUCTURE); -NODES[212].Fix(IS_STRUCTURE); -NODES[213].Fix(IS_STRUCTURE); -NODES[214].Fix(IS_STRUCTURE); -NODES[215].Fix(IS_STRUCTURE); -NODES[216].Fix(IS_STRUCTURE); -NODES[217].Fix(IS_STRUCTURE); -NODES[218].Fix(IS_STRUCTURE); -NODES[219].Fix(IS_STRUCTURE); -NODES[220].Fix(IS_STRUCTURE); -NODES[221].Fix(IS_STRUCTURE); -NODES[222].Fix(IS_STRUCTURE); -NODES[223].Fix(IS_STRUCTURE); -NODES[224].Fix(IS_STRUCTURE); -NODES[225].Fix(IS_STRUCTURE); -NODES[226].Fix(IS_STRUCTURE); -NODES[227].Fix(IS_STRUCTURE); -NODES[228].Fix(IS_STRUCTURE); -NODES[229].Fix(IS_STRUCTURE); -NODES[230].Fix(IS_STRUCTURE); -NODES[231].Fix(IS_STRUCTURE); -NODES[232].Fix(IS_STRUCTURE); -NODES[233].Fix(IS_STRUCTURE); -NODES[234].Fix(IS_STRUCTURE); -NODES[235].Fix(IS_STRUCTURE); -NODES[236].Fix(IS_STRUCTURE); -NODES[237].Fix(IS_STRUCTURE); -NODES[238].Fix(IS_STRUCTURE); -NODES[239].Fix(IS_STRUCTURE); -NODES[240].Fix(IS_STRUCTURE); -NODES[241].Fix(IS_STRUCTURE); -NODES[242].Fix(IS_STRUCTURE); -NODES[243].Fix(IS_STRUCTURE); -NODES[244].Fix(IS_STRUCTURE); -NODES[245].Fix(IS_STRUCTURE); -NODES[246].Fix(IS_STRUCTURE); -NODES[247].Fix(IS_STRUCTURE); -NODES[248].Fix(IS_STRUCTURE); -NODES[249].Fix(IS_STRUCTURE); -NODES[250].Fix(IS_STRUCTURE); -NODES[251].Fix(IS_STRUCTURE); -NODES[252].Fix(IS_STRUCTURE); -NODES[253].Fix(IS_STRUCTURE); -NODES[254].Fix(IS_STRUCTURE); -NODES[255].Fix(IS_STRUCTURE); -NODES[256].Fix(IS_STRUCTURE); -NODES[257].Fix(IS_STRUCTURE); -NODES[258].Fix(IS_STRUCTURE); -NODES[259].Fix(IS_STRUCTURE); -NODES[260].Fix(IS_STRUCTURE); -NODES[261].Fix(IS_STRUCTURE); -NODES[262].Fix(IS_STRUCTURE); -NODES[263].Fix(IS_STRUCTURE); -NODES[264].Fix(IS_STRUCTURE); -NODES[265].Fix(IS_STRUCTURE); -NODES[266].Fix(IS_STRUCTURE); -NODES[267].Fix(IS_STRUCTURE); -NODES[268].Fix(IS_STRUCTURE); -NODES[269].Fix(IS_STRUCTURE); -NODES[270].Fix(IS_STRUCTURE); -NODES[271].Fix(IS_STRUCTURE); -NODES[272].Fix(IS_STRUCTURE); -NODES[273].Fix(IS_STRUCTURE); -NODES[274].Fix(IS_STRUCTURE); -NODES[275].Fix(IS_STRUCTURE); -NODES[276].Fix(IS_STRUCTURE); -NODES[277].Fix(IS_STRUCTURE); -NODES[278].Fix(IS_STRUCTURE); -NODES[279].Fix(IS_STRUCTURE); -NODES[280].Fix(IS_STRUCTURE); -NODES[281].Fix(IS_STRUCTURE); -NODES[282].Fix(IS_STRUCTURE); -NODES[283].Fix(IS_STRUCTURE); -NODES[284].Fix(IS_STRUCTURE); -NODES[285].Fix(IS_STRUCTURE); -NODES[286].Fix(IS_STRUCTURE); -NODES[287].Fix(IS_STRUCTURE); -NODES[288].Fix(IS_STRUCTURE); -NODES[289].Fix(IS_STRUCTURE); -NODES[290].Fix(IS_STRUCTURE); -NODES[291].Fix(IS_STRUCTURE); -NODES[292].Fix(IS_STRUCTURE); -NODES[293].Fix(IS_STRUCTURE); -NODES[294].Fix(IS_STRUCTURE); -NODES[295].Fix(IS_STRUCTURE); -NODES[296].Fix(IS_STRUCTURE); -NODES[297].Fix(IS_STRUCTURE); -NODES[298].Fix(IS_STRUCTURE); -NODES[299].Fix(IS_STRUCTURE); -NODES[300].Fix(IS_STRUCTURE); -NODES[301].Fix(IS_STRUCTURE); -NODES[302].Fix(IS_STRUCTURE); -NODES[303].Fix(IS_STRUCTURE); -NODES[304].Fix(IS_STRUCTURE); -NODES[305].Fix(IS_STRUCTURE); -NODES[306].Fix(IS_STRUCTURE); -NODES[307].Fix(IS_STRUCTURE); -NODES[308].Fix(IS_STRUCTURE); -NODES[309].Fix(IS_STRUCTURE); -NODES[310].Fix(IS_STRUCTURE); -NODES[311].Fix(IS_STRUCTURE); -NODES[312].Fix(IS_STRUCTURE); -NODES[313].Fix(IS_STRUCTURE); -NODES[314].Fix(IS_STRUCTURE); -NODES[315].Fix(IS_STRUCTURE); -NODES[316].Fix(IS_STRUCTURE); -NODES[317].Fix(IS_STRUCTURE); -NODES[318].Fix(IS_STRUCTURE); -NODES[319].Fix(IS_STRUCTURE); -NODES[320].Fix(IS_STRUCTURE); -NODES[321].Fix(IS_STRUCTURE); -NODES[322].Fix(IS_STRUCTURE); -NODES[323].Fix(IS_STRUCTURE); -NODES[324].Fix(IS_STRUCTURE); -NODES[325].Fix(IS_STRUCTURE); -NODES[326].Fix(IS_STRUCTURE); -NODES[327].Fix(IS_STRUCTURE); -NODES[328].Fix(IS_STRUCTURE); -NODES[329].Fix(IS_STRUCTURE); -NODES[330].Fix(IS_STRUCTURE); -NODES[331].Fix(IS_STRUCTURE); -NODES[332].Fix(IS_STRUCTURE); -NODES[333].Fix(IS_STRUCTURE); -NODES[334].Fix(IS_STRUCTURE); -NODES[335].Fix(IS_STRUCTURE); -NODES[336].Fix(IS_STRUCTURE); -NODES[337].Fix(IS_STRUCTURE); -NODES[338].Fix(IS_STRUCTURE); -NODES[339].Fix(IS_STRUCTURE); -NODES[340].Fix(IS_STRUCTURE); -NODES[341].Fix(IS_STRUCTURE); -NODES[342].Fix(IS_STRUCTURE); -NODES[343].Fix(IS_STRUCTURE); -NODES[344].Fix(IS_STRUCTURE); -NODES[345].Fix(IS_STRUCTURE); -NODES[346].Fix(IS_STRUCTURE); -NODES[347].Fix(IS_STRUCTURE); -NODES[348].Fix(IS_STRUCTURE); -NODES[349].Fix(IS_STRUCTURE); -NODES[350].Fix(IS_STRUCTURE); -NODES[351].Fix(IS_STRUCTURE); -NODES[352].Fix(IS_STRUCTURE); -NODES[353].Fix(IS_STRUCTURE); -NODES[354].Fix(IS_STRUCTURE); -NODES[355].Fix(IS_STRUCTURE); -NODES[356].Fix(IS_STRUCTURE); -NODES[357].Fix(IS_STRUCTURE); -NODES[358].Fix(IS_STRUCTURE); -NODES[359].Fix(IS_STRUCTURE); -NODES[360].Fix(IS_STRUCTURE); -NODES[361].Fix(IS_STRUCTURE); -NODES[362].Fix(IS_STRUCTURE); -NODES[363].Fix(IS_STRUCTURE); -NODES[364].Fix(IS_STRUCTURE); -NODES[365].Fix(IS_STRUCTURE); -NODES[366].Fix(IS_STRUCTURE); -NODES[367].Fix(IS_STRUCTURE); -NODES[368].Fix(IS_STRUCTURE); -NODES[369].Fix(IS_STRUCTURE); -NODES[370].Fix(IS_STRUCTURE); -NODES[371].Fix(IS_STRUCTURE); -NODES[372].Fix(IS_STRUCTURE); -NODES[373].Fix(IS_STRUCTURE); -NODES[374].Fix(IS_STRUCTURE); -NODES[375].Fix(IS_STRUCTURE); -NODES[376].Fix(IS_STRUCTURE); -NODES[377].Fix(IS_STRUCTURE); -NODES[378].Fix(IS_STRUCTURE); -NODES[379].Fix(IS_STRUCTURE); -NODES[380].Fix(IS_STRUCTURE); -NODES[381].Fix(IS_STRUCTURE); -NODES[382].Fix(IS_STRUCTURE); -NODES[383].Fix(IS_STRUCTURE); -NODES[384].Fix(IS_STRUCTURE); -NODES[385].Fix(IS_STRUCTURE); -NODES[386].Fix(IS_STRUCTURE); -NODES[387].Fix(IS_STRUCTURE); -NODES[388].Fix(IS_STRUCTURE); -NODES[389].Fix(IS_STRUCTURE); -NODES[390].Fix(IS_STRUCTURE); -NODES[391].Fix(IS_STRUCTURE); -NODES[392].Fix(IS_STRUCTURE); -NODES[393].Fix(IS_STRUCTURE); -NODES[394].Fix(IS_STRUCTURE); -NODES[395].Fix(IS_STRUCTURE); -NODES[396].Fix(IS_STRUCTURE); -NODES[397].Fix(IS_STRUCTURE); -NODES[398].Fix(IS_STRUCTURE); -NODES[399].Fix(IS_STRUCTURE); -NODES[400].Fix(IS_STRUCTURE); -NODES[401].Fix(IS_STRUCTURE); -NODES[402].Fix(IS_STRUCTURE); -NODES[403].Fix(IS_STRUCTURE); -NODES[404].Fix(IS_STRUCTURE); -NODES[405].Fix(IS_STRUCTURE); -NODES[406].Fix(IS_STRUCTURE); -NODES[407].Fix(IS_STRUCTURE); -NODES[408].Fix(IS_STRUCTURE); -NODES[409].Fix(IS_STRUCTURE); -NODES[410].Fix(IS_STRUCTURE); -NODES[411].Fix(IS_STRUCTURE); -NODES[412].Fix(IS_STRUCTURE); -NODES[413].Fix(IS_STRUCTURE); -NODES[414].Fix(IS_STRUCTURE); -NODES[415].Fix(IS_STRUCTURE); -NODES[416].Fix(IS_STRUCTURE); -NODES[417].Fix(IS_STRUCTURE); -NODES[418].Fix(IS_STRUCTURE); -NODES[419].Fix(IS_STRUCTURE); -NODES[420].Fix(IS_STRUCTURE); -NODES[421].Fix(IS_STRUCTURE); -NODES[422].Fix(IS_STRUCTURE); -NODES[423].Fix(IS_STRUCTURE); -NODES[424].Fix(IS_STRUCTURE); -NODES[425].Fix(IS_STRUCTURE); -NODES[426].Fix(IS_STRUCTURE); -NODES[427].Fix(IS_STRUCTURE); -NODES[428].Fix(IS_STRUCTURE); -NODES[429].Fix(IS_STRUCTURE); -NODES[430].Fix(IS_STRUCTURE); -NODES[431].Fix(IS_STRUCTURE); -NODES[432].Fix(IS_STRUCTURE); -NODES[433].Fix(IS_STRUCTURE); -NODES[434].Fix(IS_STRUCTURE); -NODES[435].Fix(IS_STRUCTURE); -NODES[436].Fix(IS_STRUCTURE); -NODES[437].Fix(IS_STRUCTURE); -NODES[438].Fix(IS_STRUCTURE); -NODES[439].Fix(IS_STRUCTURE); -NODES[440].Fix(IS_STRUCTURE); -NODES[441].Fix(IS_STRUCTURE); -NODES[442].Fix(IS_STRUCTURE); -NODES[443].Fix(IS_STRUCTURE); -NODES[444].Fix(IS_STRUCTURE); -NODES[445].Fix(IS_STRUCTURE); -NODES[446].Fix(IS_STRUCTURE); -NODES[447].Fix(IS_STRUCTURE); -NODES[448].Fix(IS_STRUCTURE); -NODES[449].Fix(IS_STRUCTURE); -NODES[450].Fix(IS_STRUCTURE); -NODES[451].Fix(IS_STRUCTURE); -NODES[452].Fix(IS_STRUCTURE); -NODES[453].Fix(IS_STRUCTURE); -NODES[454].Fix(IS_STRUCTURE); -NODES[455].Fix(IS_STRUCTURE); -NODES[456].Fix(IS_STRUCTURE); -NODES[457].Fix(IS_STRUCTURE); -NODES[458].Fix(IS_STRUCTURE); -NODES[459].Fix(IS_STRUCTURE); -NODES[460].Fix(IS_STRUCTURE); -NODES[461].Fix(IS_STRUCTURE); -NODES[462].Fix(IS_STRUCTURE); -NODES[463].Fix(IS_STRUCTURE); -NODES[464].Fix(IS_STRUCTURE); -NODES[465].Fix(IS_STRUCTURE); -NODES[466].Fix(IS_STRUCTURE); -NODES[467].Fix(IS_STRUCTURE); -NODES[468].Fix(IS_STRUCTURE); -NODES[469].Fix(IS_STRUCTURE); -NODES[470].Fix(IS_STRUCTURE); -NODES[471].Fix(IS_STRUCTURE); -NODES[472].Fix(IS_STRUCTURE); -NODES[473].Fix(IS_STRUCTURE); -NODES[474].Fix(IS_STRUCTURE); -NODES[475].Fix(IS_STRUCTURE); -NODES[476].Fix(IS_STRUCTURE); -NODES[477].Fix(IS_STRUCTURE); -NODES[478].Fix(IS_STRUCTURE); -NODES[479].Fix(IS_STRUCTURE); -NODES[480].Fix(IS_STRUCTURE); -NODES[481].Fix(IS_STRUCTURE); -NODES[482].Fix(IS_STRUCTURE); -NODES[483].Fix(IS_STRUCTURE); -NODES[484].Fix(IS_STRUCTURE); -NODES[485].Fix(IS_STRUCTURE); -NODES[486].Fix(IS_STRUCTURE); -NODES[487].Fix(IS_STRUCTURE); -NODES[488].Fix(IS_STRUCTURE); -NODES[489].Fix(IS_STRUCTURE); -NODES[490].Fix(IS_STRUCTURE); -NODES[491].Fix(IS_STRUCTURE); -NODES[492].Fix(IS_STRUCTURE); -NODES[493].Fix(IS_STRUCTURE); -NODES[494].Fix(IS_STRUCTURE); -NODES[495].Fix(IS_STRUCTURE); -NODES[496].Fix(IS_STRUCTURE); -NODES[497].Fix(IS_STRUCTURE); -NODES[498].Fix(IS_STRUCTURE); -NODES[499].Fix(IS_STRUCTURE); -NODES[500].Fix(IS_STRUCTURE); -NODES[501].Fix(IS_STRUCTURE); -NODES[502].Fix(IS_STRUCTURE); -NODES[503].Fix(IS_STRUCTURE); -NODES[504].Fix(IS_STRUCTURE); -NODES[505].Fix(IS_STRUCTURE); -NODES[506].Fix(IS_STRUCTURE); -NODES[507].Fix(IS_STRUCTURE); -NODES[508].Fix(IS_STRUCTURE); -NODES[509].Fix(IS_STRUCTURE); -NODES[510].Fix(IS_STRUCTURE); -NODES[511].Fix(IS_STRUCTURE); -NODES[512].Fix(IS_STRUCTURE); -NODES[513].Fix(IS_STRUCTURE); -NODES[514].Fix(IS_STRUCTURE); -NODES[515].Fix(IS_STRUCTURE); -NODES[516].Fix(IS_STRUCTURE); -NODES[517].Fix(IS_STRUCTURE); -NODES[518].Fix(IS_STRUCTURE); -NODES[519].Fix(IS_STRUCTURE); -NODES[520].Fix(IS_STRUCTURE); -NODES[521].Fix(IS_STRUCTURE); -NODES[522].Fix(IS_STRUCTURE); -NODES[523].Fix(IS_STRUCTURE); -NODES[524].Fix(IS_STRUCTURE); -NODES[525].Fix(IS_STRUCTURE); -NODES[526].Fix(IS_STRUCTURE); -NODES[527].Fix(IS_STRUCTURE); -NODES[528].Fix(IS_STRUCTURE); -NODES[529].Fix(IS_STRUCTURE); -NODES[530].Fix(IS_STRUCTURE); -NODES[531].Fix(IS_STRUCTURE); -NODES[532].Fix(IS_STRUCTURE); -NODES[533].Fix(IS_STRUCTURE); -NODES[534].Fix(IS_STRUCTURE); -NODES[535].Fix(IS_STRUCTURE); -NODES[536].Fix(IS_STRUCTURE); -NODES[537].Fix(IS_STRUCTURE); -NODES[538].Fix(IS_STRUCTURE); -NODES[539].Fix(IS_STRUCTURE); -NODES[540].Fix(IS_STRUCTURE); -NODES[541].Fix(IS_STRUCTURE); -NODES[542].Fix(IS_STRUCTURE); -NODES[543].Fix(IS_STRUCTURE); -NODES[544].Fix(IS_STRUCTURE); -NODES[545].Fix(IS_STRUCTURE); -NODES[546].Fix(IS_STRUCTURE); -NODES[547].Fix(IS_STRUCTURE); -NODES[548].Fix(IS_STRUCTURE); -NODES[549].Fix(IS_STRUCTURE); -NODES[550].Fix(IS_STRUCTURE); -NODES[551].Fix(IS_STRUCTURE); -NODES[552].Fix(IS_STRUCTURE); -NODES[553].Fix(IS_STRUCTURE); -NODES[554].Fix(IS_STRUCTURE); -NODES[555].Fix(IS_STRUCTURE); -NODES[556].Fix(IS_STRUCTURE); -NODES[557].Fix(IS_STRUCTURE); -NODES[558].Fix(IS_STRUCTURE); -NODES[559].Fix(IS_STRUCTURE); -NODES[560].Fix(IS_STRUCTURE); -NODES[561].Fix(IS_STRUCTURE); -NODES[562].Fix(IS_STRUCTURE); -NODES[563].Fix(IS_STRUCTURE); -NODES[564].Fix(IS_STRUCTURE); -NODES[565].Fix(IS_STRUCTURE); -NODES[566].Fix(IS_STRUCTURE); -NODES[567].Fix(IS_STRUCTURE); -NODES[568].Fix(IS_STRUCTURE); -NODES[569].Fix(IS_STRUCTURE); -NODES[570].Fix(IS_STRUCTURE); -NODES[571].Fix(IS_STRUCTURE); -NODES[572].Fix(IS_STRUCTURE); -NODES[573].Fix(IS_STRUCTURE); -NODES[574].Fix(IS_STRUCTURE); -NODES[575].Fix(IS_STRUCTURE); -NODES[576].Fix(IS_STRUCTURE); -NODES[577].Fix(IS_STRUCTURE); -NODES[578].Fix(IS_STRUCTURE); -NODES[579].Fix(IS_STRUCTURE); -NODES[580].Fix(IS_STRUCTURE); -NODES[581].Fix(IS_STRUCTURE); -NODES[582].Fix(IS_STRUCTURE); -NODES[583].Fix(IS_STRUCTURE); -NODES[584].Fix(IS_STRUCTURE); -NODES[585].Fix(IS_STRUCTURE); -NODES[586].Fix(IS_STRUCTURE); -NODES[587].Fix(IS_STRUCTURE); -NODES[588].Fix(IS_STRUCTURE); -NODES[589].Fix(IS_STRUCTURE); -NODES[590].Fix(IS_STRUCTURE); -NODES[591].Fix(IS_STRUCTURE); -NODES[592].Fix(IS_STRUCTURE); -NODES[593].Fix(IS_STRUCTURE); -NODES[594].Fix(IS_STRUCTURE); -NODES[595].Fix(IS_STRUCTURE); -NODES[596].Fix(IS_STRUCTURE); -NODES[597].Fix(IS_STRUCTURE); -NODES[598].Fix(IS_STRUCTURE); -NODES[599].Fix(IS_STRUCTURE); -NODES[600].Fix(IS_STRUCTURE); -NODES[601].Fix(IS_STRUCTURE); -NODES[602].Fix(IS_STRUCTURE); -NODES[603].Fix(IS_STRUCTURE); -NODES[604].Fix(IS_STRUCTURE); -NODES[605].Fix(IS_STRUCTURE); -NODES[606].Fix(IS_STRUCTURE); -NODES[607].Fix(IS_STRUCTURE); -NODES[608].Fix(IS_STRUCTURE); -NODES[609].Fix(IS_STRUCTURE); -NODES[610].Fix(IS_STRUCTURE); -NODES[611].Fix(IS_STRUCTURE); -NODES[612].Fix(IS_STRUCTURE); -NODES[613].Fix(IS_STRUCTURE); -NODES[614].Fix(IS_STRUCTURE); -NODES[615].Fix(IS_STRUCTURE); -NODES[616].Fix(IS_STRUCTURE); -NODES[617].Fix(IS_STRUCTURE); -NODES[618].Fix(IS_STRUCTURE); -NODES[619].Fix(IS_STRUCTURE); -NODES[620].Fix(IS_STRUCTURE); -NODES[621].Fix(IS_STRUCTURE); -NODES[622].Fix(IS_STRUCTURE); -NODES[623].Fix(IS_STRUCTURE); -NODES[624].Fix(IS_STRUCTURE); -NODES[625].Fix(IS_STRUCTURE); -NODES[626].Fix(IS_STRUCTURE); -NODES[627].Fix(IS_STRUCTURE); -NODES[628].Fix(IS_STRUCTURE); -NODES[629].Fix(IS_STRUCTURE); -NODES[630].Fix(IS_STRUCTURE); -NODES[631].Fix(IS_STRUCTURE); -NODES[632].Fix(IS_STRUCTURE); -NODES[633].Fix(IS_STRUCTURE); -NODES[634].Fix(IS_STRUCTURE); -NODES[635].Fix(IS_STRUCTURE); -NODES[636].Fix(IS_STRUCTURE); -NODES[637].Fix(IS_STRUCTURE); -NODES[638].Fix(IS_STRUCTURE); -NODES[639].Fix(IS_STRUCTURE); -NODES[640].Fix(IS_STRUCTURE); -NODES[641].Fix(IS_STRUCTURE); -NODES[642].Fix(IS_STRUCTURE); -NODES[643].Fix(IS_STRUCTURE); -NODES[644].Fix(IS_STRUCTURE); -NODES[645].Fix(IS_STRUCTURE); -NODES[646].Fix(IS_STRUCTURE); -NODES[647].Fix(IS_STRUCTURE); -NODES[648].Fix(IS_STRUCTURE); -NODES[649].Fix(IS_STRUCTURE); -NODES[650].Fix(IS_STRUCTURE); -NODES[651].Fix(IS_STRUCTURE); -NODES[652].Fix(IS_STRUCTURE); -NODES[653].Fix(IS_STRUCTURE); -NODES[654].Fix(IS_STRUCTURE); -NODES[655].Fix(IS_STRUCTURE); -NODES[656].Fix(IS_STRUCTURE); -NODES[657].Fix(IS_STRUCTURE); -NODES[658].Fix(IS_STRUCTURE); -NODES[659].Fix(IS_STRUCTURE); -NODES[660].Fix(IS_STRUCTURE); -NODES[661].Fix(IS_STRUCTURE); -NODES[662].Fix(IS_STRUCTURE); -NODES[663].Fix(IS_STRUCTURE); -NODES[664].Fix(IS_STRUCTURE); -NODES[665].Fix(IS_STRUCTURE); -NODES[666].Fix(IS_STRUCTURE); -NODES[667].Fix(IS_STRUCTURE); -NODES[668].Fix(IS_STRUCTURE); -NODES[669].Fix(IS_STRUCTURE); -NODES[670].Fix(IS_STRUCTURE); -NODES[671].Fix(IS_STRUCTURE); -NODES[672].Fix(IS_STRUCTURE); -NODES[673].Fix(IS_STRUCTURE); -NODES[674].Fix(IS_STRUCTURE); -NODES[675].Fix(IS_STRUCTURE); -NODES[676].Fix(IS_STRUCTURE); -NODES[677].Fix(IS_STRUCTURE); -NODES[678].Fix(IS_STRUCTURE); -NODES[679].Fix(IS_STRUCTURE); -NODES[680].Fix(IS_STRUCTURE); -NODES[681].Fix(IS_STRUCTURE); -NODES[682].Fix(IS_STRUCTURE); -NODES[683].Fix(IS_STRUCTURE); -NODES[684].Fix(IS_STRUCTURE); -NODES[685].Fix(IS_STRUCTURE); -NODES[686].Fix(IS_STRUCTURE); -NODES[687].Fix(IS_STRUCTURE); -NODES[688].Fix(IS_STRUCTURE); -NODES[689].Fix(IS_STRUCTURE); -NODES[690].Fix(IS_STRUCTURE); -NODES[691].Fix(IS_STRUCTURE); -NODES[692].Fix(IS_STRUCTURE); -NODES[693].Fix(IS_STRUCTURE); -NODES[694].Fix(IS_STRUCTURE); -NODES[695].Fix(IS_STRUCTURE); -NODES[696].Fix(IS_STRUCTURE); -NODES[697].Fix(IS_STRUCTURE); -NODES[698].Fix(IS_STRUCTURE); -NODES[699].Fix(IS_STRUCTURE); -NODES[700].Fix(IS_STRUCTURE); -NODES[701].Fix(IS_STRUCTURE); -NODES[702].Fix(IS_STRUCTURE); -NODES[703].Fix(IS_STRUCTURE); -NODES[704].Fix(IS_STRUCTURE); -NODES[705].Fix(IS_STRUCTURE); -NODES[706].Fix(IS_STRUCTURE); -NODES[707].Fix(IS_STRUCTURE); -NODES[708].Fix(IS_STRUCTURE); -NODES[709].Fix(IS_STRUCTURE); -NODES[710].Fix(IS_STRUCTURE); -NODES[711].Fix(IS_STRUCTURE); -NODES[712].Fix(IS_STRUCTURE); -NODES[713].Fix(IS_STRUCTURE); -NODES[714].Fix(IS_STRUCTURE); -NODES[715].Fix(IS_STRUCTURE); -NODES[716].Fix(IS_STRUCTURE); -NODES[717].Fix(IS_STRUCTURE); -NODES[718].Fix(IS_STRUCTURE); -NODES[719].Fix(IS_STRUCTURE); -NODES[720].Fix(IS_STRUCTURE); -NODES[721].Fix(IS_STRUCTURE); -NODES[722].Fix(IS_STRUCTURE); -NODES[723].Fix(IS_STRUCTURE); -NODES[724].Fix(IS_STRUCTURE); -NODES[725].Fix(IS_STRUCTURE); -NODES[726].Fix(IS_STRUCTURE); -NODES[727].Fix(IS_STRUCTURE); -NODES[728].Fix(IS_STRUCTURE); -NODES[729].Fix(IS_STRUCTURE); -NODES[730].Fix(IS_STRUCTURE); -NODES[731].Fix(IS_STRUCTURE); -NODES[732].Fix(IS_STRUCTURE); -NODES[733].Fix(IS_STRUCTURE); -NODES[734].Fix(IS_STRUCTURE); -NODES[735].Fix(IS_STRUCTURE); -NODES[736].Fix(IS_STRUCTURE); -NODES[737].Fix(IS_STRUCTURE); -NODES[738].Fix(IS_STRUCTURE); -NODES[739].Fix(IS_STRUCTURE); -NODES[740].Fix(IS_STRUCTURE); -NODES[741].Fix(IS_STRUCTURE); -NODES[742].Fix(IS_STRUCTURE); -NODES[743].Fix(IS_STRUCTURE); -NODES[744].Fix(IS_STRUCTURE); -NODES[745].Fix(IS_STRUCTURE); -NODES[746].Fix(IS_STRUCTURE); -NODES[747].Fix(IS_STRUCTURE); -NODES[748].Fix(IS_STRUCTURE); -NODES[749].Fix(IS_STRUCTURE); -NODES[750].Fix(IS_STRUCTURE); -NODES[751].Fix(IS_STRUCTURE); -NODES[752].Fix(IS_STRUCTURE); -NODES[753].Fix(IS_STRUCTURE); -NODES[754].Fix(IS_STRUCTURE); -NODES[755].Fix(IS_STRUCTURE); -NODES[756].Fix(IS_STRUCTURE); -NODES[757].Fix(IS_STRUCTURE); -NODES[758].Fix(IS_STRUCTURE); -NODES[759].Fix(IS_STRUCTURE); -NODES[760].Fix(IS_STRUCTURE); -NODES[761].Fix(IS_STRUCTURE); -NODES[762].Fix(IS_STRUCTURE); -NODES[763].Fix(IS_STRUCTURE); -NODES[764].Fix(IS_STRUCTURE); -NODES[765].Fix(IS_STRUCTURE); -NODES[766].Fix(IS_STRUCTURE); -NODES[767].Fix(IS_STRUCTURE); -NODES[768].Fix(IS_STRUCTURE); -NODES[769].Fix(IS_STRUCTURE); -NODES[770].Fix(IS_STRUCTURE); -NODES[771].Fix(IS_STRUCTURE); -NODES[772].Fix(IS_STRUCTURE); -NODES[773].Fix(IS_STRUCTURE); -NODES[774].Fix(IS_STRUCTURE); -NODES[775].Fix(IS_STRUCTURE); -NODES[776].Fix(IS_STRUCTURE); -NODES[777].Fix(IS_STRUCTURE); -NODES[778].Fix(IS_STRUCTURE); -NODES[779].Fix(IS_STRUCTURE); -NODES[780].Fix(IS_STRUCTURE); -NODES[781].Fix(IS_STRUCTURE); -NODES[782].Fix(IS_STRUCTURE); -NODES[783].Fix(IS_STRUCTURE); -NODES[784].Fix(IS_STRUCTURE); -NODES[785].Fix(IS_STRUCTURE); -NODES[786].Fix(IS_STRUCTURE); -NODES[787].Fix(IS_STRUCTURE); -NODES[788].Fix(IS_STRUCTURE); -NODES[789].Fix(IS_STRUCTURE); -NODES[790].Fix(IS_STRUCTURE); -NODES[791].Fix(IS_STRUCTURE); -NODES[792].Fix(IS_STRUCTURE); -NODES[793].Fix(IS_STRUCTURE); -NODES[794].Fix(IS_STRUCTURE); -NODES[795].Fix(IS_STRUCTURE); -NODES[796].Fix(IS_STRUCTURE); -NODES[797].Fix(IS_STRUCTURE); -NODES[798].Fix(IS_STRUCTURE); -NODES[799].Fix(IS_STRUCTURE); -NODES[800].Fix(IS_STRUCTURE); -NODES[801].Fix(IS_STRUCTURE); -NODES[802].Fix(IS_STRUCTURE); -NODES[803].Fix(IS_STRUCTURE); -NODES[804].Fix(IS_STRUCTURE); -NODES[805].Fix(IS_STRUCTURE); -NODES[806].Fix(IS_STRUCTURE); -NODES[807].Fix(IS_STRUCTURE); -NODES[808].Fix(IS_STRUCTURE); -NODES[809].Fix(IS_STRUCTURE); -NODES[810].Fix(IS_STRUCTURE); -NODES[811].Fix(IS_STRUCTURE); -NODES[812].Fix(IS_STRUCTURE); -NODES[813].Fix(IS_STRUCTURE); -NODES[814].Fix(IS_STRUCTURE); -NODES[815].Fix(IS_STRUCTURE); -NODES[816].Fix(IS_STRUCTURE); -NODES[817].Fix(IS_STRUCTURE); -NODES[818].Fix(IS_STRUCTURE); -NODES[819].Fix(IS_STRUCTURE); -NODES[820].Fix(IS_STRUCTURE); -NODES[821].Fix(IS_STRUCTURE); -NODES[822].Fix(IS_STRUCTURE); -NODES[823].Fix(IS_STRUCTURE); -NODES[824].Fix(IS_STRUCTURE); -NODES[825].Fix(IS_STRUCTURE); -NODES[826].Fix(IS_STRUCTURE); -NODES[827].Fix(IS_STRUCTURE); -NODES[828].Fix(IS_STRUCTURE); -NODES[829].Fix(IS_STRUCTURE); -NODES[830].Fix(IS_STRUCTURE); -NODES[831].Fix(IS_STRUCTURE); -NODES[832].Fix(IS_STRUCTURE); -NODES[833].Fix(IS_STRUCTURE); -NODES[834].Fix(IS_STRUCTURE); -NODES[835].Fix(IS_STRUCTURE); -NODES[836].Fix(IS_STRUCTURE); -NODES[837].Fix(IS_STRUCTURE); -NODES[838].Fix(IS_STRUCTURE); -NODES[839].Fix(IS_STRUCTURE); -NODES[840].Fix(IS_STRUCTURE); -NODES[841].Fix(IS_STRUCTURE); -NODES[842].Fix(IS_STRUCTURE); -NODES[843].Fix(IS_STRUCTURE); -NODES[844].Fix(IS_STRUCTURE); -NODES[845].Fix(IS_STRUCTURE); -NODES[846].Fix(IS_STRUCTURE); -NODES[847].Fix(IS_STRUCTURE); -NODES[848].Fix(IS_STRUCTURE); -NODES[849].Fix(IS_STRUCTURE); -NODES[850].Fix(IS_STRUCTURE); -NODES[851].Fix(IS_STRUCTURE); -NODES[852].Fix(IS_STRUCTURE); -NODES[853].Fix(IS_STRUCTURE); -NODES[854].Fix(IS_STRUCTURE); -NODES[855].Fix(IS_STRUCTURE); -NODES[856].Fix(IS_STRUCTURE); -NODES[857].Fix(IS_STRUCTURE); -NODES[858].Fix(IS_STRUCTURE); -NODES[859].Fix(IS_STRUCTURE); -NODES[860].Fix(IS_STRUCTURE); -NODES[861].Fix(IS_STRUCTURE); -NODES[862].Fix(IS_STRUCTURE); -NODES[863].Fix(IS_STRUCTURE); -NODES[864].Fix(IS_STRUCTURE); -NODES[865].Fix(IS_STRUCTURE); -NODES[866].Fix(IS_STRUCTURE); -NODES[867].Fix(IS_STRUCTURE); -NODES[868].Fix(IS_STRUCTURE); -NODES[869].Fix(IS_STRUCTURE); -NODES[870].Fix(IS_STRUCTURE); -NODES[871].Fix(IS_STRUCTURE); -NODES[872].Fix(IS_STRUCTURE); -NODES[873].Fix(IS_STRUCTURE); -NODES[874].Fix(IS_STRUCTURE); -NODES[875].Fix(IS_STRUCTURE); -NODES[876].Fix(IS_STRUCTURE); -NODES[877].Fix(IS_STRUCTURE); -NODES[878].Fix(IS_STRUCTURE); -NODES[879].Fix(IS_STRUCTURE); -NODES[880].Fix(IS_STRUCTURE); -NODES[881].Fix(IS_STRUCTURE); -NODES[882].Fix(IS_STRUCTURE); -NODES[883].Fix(IS_STRUCTURE); -NODES[884].Fix(IS_STRUCTURE); -NODES[885].Fix(IS_STRUCTURE); -NODES[886].Fix(IS_STRUCTURE); -NODES[887].Fix(IS_STRUCTURE); -NODES[888].Fix(IS_STRUCTURE); -NODES[889].Fix(IS_STRUCTURE); -NODES[890].Fix(IS_STRUCTURE); -NODES[891].Fix(IS_STRUCTURE); -NODES[892].Fix(IS_STRUCTURE); -NODES[893].Fix(IS_STRUCTURE); -NODES[894].Fix(IS_STRUCTURE); -NODES[895].Fix(IS_STRUCTURE); -NODES[896].Fix(IS_STRUCTURE); -NODES[897].Fix(IS_STRUCTURE); -NODES[898].Fix(IS_STRUCTURE); -NODES[899].Fix(IS_STRUCTURE); -NODES[900].Fix(IS_STRUCTURE); -NODES[901].Fix(IS_STRUCTURE); -NODES[902].Fix(IS_STRUCTURE); -NODES[903].Fix(IS_STRUCTURE); -NODES[904].Fix(IS_STRUCTURE); -NODES[905].Fix(IS_STRUCTURE); -NODES[906].Fix(IS_STRUCTURE); -NODES[907].Fix(IS_STRUCTURE); -NODES[908].Fix(IS_STRUCTURE); -NODES[909].Fix(IS_STRUCTURE); -NODES[910].Fix(IS_STRUCTURE); -NODES[911].Fix(IS_STRUCTURE); -NODES[912].Fix(IS_STRUCTURE); -NODES[913].Fix(IS_STRUCTURE); -NODES[914].Fix(IS_STRUCTURE); -NODES[915].Fix(IS_STRUCTURE); -NODES[916].Fix(IS_STRUCTURE); -NODES[917].Fix(IS_STRUCTURE); -NODES[918].Fix(IS_STRUCTURE); -NODES[919].Fix(IS_STRUCTURE); -NODES[920].Fix(IS_STRUCTURE); -NODES[921].Fix(IS_STRUCTURE); -NODES[922].Fix(IS_STRUCTURE); -NODES[923].Fix(IS_STRUCTURE); -NODES[924].Fix(IS_STRUCTURE); -NODES[925].Fix(IS_STRUCTURE); -NODES[926].Fix(IS_STRUCTURE); -NODES[927].Fix(IS_STRUCTURE); -NODES[928].Fix(IS_STRUCTURE); -NODES[929].Fix(IS_STRUCTURE); -NODES[930].Fix(IS_STRUCTURE); -NODES[931].Fix(IS_STRUCTURE); -NODES[932].Fix(IS_STRUCTURE); -NODES[933].Fix(IS_STRUCTURE); -NODES[934].Fix(IS_STRUCTURE); -NODES[935].Fix(IS_STRUCTURE); -NODES[936].Fix(IS_STRUCTURE); -NODES[937].Fix(IS_STRUCTURE); -NODES[938].Fix(IS_STRUCTURE); -NODES[939].Fix(IS_STRUCTURE); -NODES[940].Fix(IS_STRUCTURE); -NODES[941].Fix(IS_STRUCTURE); -NODES[942].Fix(IS_STRUCTURE); -NODES[943].Fix(IS_STRUCTURE); -NODES[944].Fix(IS_STRUCTURE); -NODES[945].Fix(IS_STRUCTURE); -NODES[946].Fix(IS_STRUCTURE); -NODES[947].Fix(IS_STRUCTURE); -NODES[948].Fix(IS_STRUCTURE); -NODES[949].Fix(IS_STRUCTURE); -NODES[950].Fix(IS_STRUCTURE); -NODES[951].Fix(IS_STRUCTURE); -NODES[952].Fix(IS_STRUCTURE); -NODES[953].Fix(IS_STRUCTURE); -NODES[954].Fix(IS_STRUCTURE); -NODES[955].Fix(IS_STRUCTURE); -NODES[956].Fix(IS_STRUCTURE); -NODES[957].Fix(IS_STRUCTURE); -NODES[958].Fix(IS_STRUCTURE); -NODES[959].Fix(IS_STRUCTURE); -NODES[960].Fix(IS_STRUCTURE); -NODES[961].Fix(IS_STRUCTURE); -NODES[962].Fix(IS_STRUCTURE); -NODES[963].Fix(IS_STRUCTURE); -NODES[964].Fix(IS_STRUCTURE); -NODES[965].Fix(IS_STRUCTURE); -NODES[966].Fix(IS_STRUCTURE); -NODES[967].Fix(IS_STRUCTURE); -NODES[968].Fix(IS_STRUCTURE); -NODES[969].Fix(IS_STRUCTURE); -NODES[970].Fix(IS_STRUCTURE); -NODES[971].Fix(IS_STRUCTURE); -NODES[972].Fix(IS_STRUCTURE); -NODES[973].Fix(IS_STRUCTURE); -NODES[974].Fix(IS_STRUCTURE); -NODES[975].Fix(IS_STRUCTURE); -NODES[976].Fix(IS_STRUCTURE); -NODES[977].Fix(IS_STRUCTURE); -NODES[978].Fix(IS_STRUCTURE); -NODES[979].Fix(IS_STRUCTURE); -NODES[980].Fix(IS_STRUCTURE); -NODES[981].Fix(IS_STRUCTURE); -NODES[982].Fix(IS_STRUCTURE); -NODES[983].Fix(IS_STRUCTURE); -NODES[984].Fix(IS_STRUCTURE); -NODES[985].Fix(IS_STRUCTURE); -NODES[986].Fix(IS_STRUCTURE); -NODES[987].Fix(IS_STRUCTURE); -NODES[988].Fix(IS_STRUCTURE); -NODES[989].Fix(IS_STRUCTURE); -NODES[990].Fix(IS_STRUCTURE); -NODES[991].Fix(IS_STRUCTURE); -NODES[992].Fix(IS_STRUCTURE); -NODES[993].Fix(IS_STRUCTURE); -NODES[994].Fix(IS_STRUCTURE); -NODES[995].Fix(IS_STRUCTURE); -NODES[996].Fix(IS_STRUCTURE); -NODES[997].Fix(IS_STRUCTURE); -NODES[998].Fix(IS_STRUCTURE); -NODES[999].Fix(IS_STRUCTURE); -NODES[1000].Fix(IS_STRUCTURE); -NODES[1001].Fix(IS_STRUCTURE); -NODES[1002].Fix(IS_STRUCTURE); -NODES[1003].Fix(IS_STRUCTURE); -NODES[1004].Fix(IS_STRUCTURE); -NODES[1005].Fix(IS_STRUCTURE); -NODES[1006].Fix(IS_STRUCTURE); -NODES[1007].Fix(IS_STRUCTURE); -NODES[1008].Fix(IS_STRUCTURE); -NODES[1009].Fix(IS_STRUCTURE); -NODES[1010].Fix(IS_STRUCTURE); -NODES[1011].Fix(IS_STRUCTURE); -NODES[1012].Fix(IS_STRUCTURE); -NODES[1013].Fix(IS_STRUCTURE); -NODES[1014].Fix(IS_STRUCTURE); -NODES[1015].Fix(IS_STRUCTURE); -NODES[1016].Fix(IS_STRUCTURE); -NODES[1017].Fix(IS_STRUCTURE); -NODES[1018].Fix(IS_STRUCTURE); -NODES[1019].Fix(IS_STRUCTURE); -NODES[1020].Fix(IS_STRUCTURE); -NODES[1021].Fix(IS_STRUCTURE); -NODES[1022].Fix(IS_STRUCTURE); -NODES[1023].Fix(IS_STRUCTURE); -NODES[1024].Fix(IS_STRUCTURE); -NODES[1025].Fix(IS_STRUCTURE); -NODES[1026].Fix(IS_STRUCTURE); -NODES[1027].Fix(IS_STRUCTURE); -NODES[1028].Fix(IS_STRUCTURE); -NODES[1029].Fix(IS_STRUCTURE); -NODES[1030].Fix(IS_STRUCTURE); -NODES[1031].Fix(IS_STRUCTURE); -NODES[1032].Fix(IS_STRUCTURE); -NODES[1033].Fix(IS_STRUCTURE); -NODES[1034].Fix(IS_STRUCTURE); -NODES[1035].Fix(IS_STRUCTURE); -NODES[1036].Fix(IS_STRUCTURE); -NODES[1037].Fix(IS_STRUCTURE); -NODES[1038].Fix(IS_STRUCTURE); -NODES[1039].Fix(IS_STRUCTURE); -NODES[1040].Fix(IS_STRUCTURE); -NODES[1041].Fix(IS_STRUCTURE); -NODES[1042].Fix(IS_STRUCTURE); -NODES[1043].Fix(IS_STRUCTURE); -NODES[1044].Fix(IS_STRUCTURE); -NODES[1045].Fix(IS_STRUCTURE); -NODES[1046].Fix(IS_STRUCTURE); -NODES[1047].Fix(IS_STRUCTURE); -NODES[1048].Fix(IS_STRUCTURE); -NODES[1049].Fix(IS_STRUCTURE); -NODES[1050].Fix(IS_STRUCTURE); -NODES[1051].Fix(IS_STRUCTURE); -NODES[1052].Fix(IS_STRUCTURE); -NODES[1053].Fix(IS_STRUCTURE); -NODES[1054].Fix(IS_STRUCTURE); -NODES[1055].Fix(IS_STRUCTURE); -NODES[1056].Fix(IS_STRUCTURE); -NODES[1057].Fix(IS_STRUCTURE); -NODES[1058].Fix(IS_STRUCTURE); -NODES[1059].Fix(IS_STRUCTURE); -NODES[1060].Fix(IS_STRUCTURE); -NODES[1061].Fix(IS_STRUCTURE); -NODES[1062].Fix(IS_STRUCTURE); -NODES[1063].Fix(IS_STRUCTURE); -NODES[1064].Fix(IS_STRUCTURE); -NODES[1065].Fix(IS_STRUCTURE); -NODES[1066].Fix(IS_STRUCTURE); -NODES[1067].Fix(IS_STRUCTURE); -NODES[1068].Fix(IS_STRUCTURE); -NODES[1069].Fix(IS_STRUCTURE); -NODES[1070].Fix(IS_STRUCTURE); -NODES[1071].Fix(IS_STRUCTURE); -NODES[1072].Fix(IS_STRUCTURE); -NODES[1073].Fix(IS_STRUCTURE); -NODES[1074].Fix(IS_STRUCTURE); -NODES[1075].Fix(IS_STRUCTURE); -NODES[1076].Fix(IS_STRUCTURE); -NODES[1077].Fix(IS_STRUCTURE); -NODES[1078].Fix(IS_STRUCTURE); -NODES[1079].Fix(IS_STRUCTURE); -NODES[1080].Fix(IS_STRUCTURE); -NODES[1081].Fix(IS_STRUCTURE); -NODES[1082].Fix(IS_STRUCTURE); -NODES[1083].Fix(IS_STRUCTURE); -NODES[1084].Fix(IS_STRUCTURE); -NODES[1085].Fix(IS_STRUCTURE); -NODES[1086].Fix(IS_STRUCTURE); -NODES[1087].Fix(IS_STRUCTURE); -NODES[1088].Fix(IS_STRUCTURE); -NODES[1089].Fix(IS_STRUCTURE); -NODES[1090].Fix(IS_STRUCTURE); -NODES[1091].Fix(IS_STRUCTURE); -NODES[1092].Fix(IS_STRUCTURE); -NODES[1093].Fix(IS_STRUCTURE); -NODES[1094].Fix(IS_STRUCTURE); -NODES[1095].Fix(IS_STRUCTURE); -NODES[1096].Fix(IS_STRUCTURE); -NODES[1097].Fix(IS_STRUCTURE); -NODES[1098].Fix(IS_STRUCTURE); -NODES[1099].Fix(IS_STRUCTURE); -NODES[1100].Fix(IS_STRUCTURE); -NODES[1101].Fix(IS_STRUCTURE); -NODES[1102].Fix(IS_STRUCTURE); -NODES[1103].Fix(IS_STRUCTURE); -NODES[1104].Fix(IS_STRUCTURE); -NODES[1105].Fix(IS_STRUCTURE); -NODES[1106].Fix(IS_STRUCTURE); -NODES[1107].Fix(IS_STRUCTURE); -NODES[1108].Fix(IS_STRUCTURE); -NODES[1109].Fix(IS_STRUCTURE); -NODES[1110].Fix(IS_STRUCTURE); -NODES[1111].Fix(IS_STRUCTURE); -NODES[1112].Fix(IS_STRUCTURE); -NODES[1113].Fix(IS_STRUCTURE); -NODES[1114].Fix(IS_STRUCTURE); -NODES[1115].Fix(IS_STRUCTURE); -NODES[1116].Fix(IS_STRUCTURE); -NODES[1117].Fix(IS_STRUCTURE); -NODES[1118].Fix(IS_STRUCTURE); -NODES[1119].Fix(IS_STRUCTURE); -NODES[1120].Fix(IS_STRUCTURE); -NODES[1121].Fix(IS_STRUCTURE); -NODES[1122].Fix(IS_STRUCTURE); -NODES[1123].Fix(IS_STRUCTURE); -NODES[1124].Fix(IS_STRUCTURE); -NODES[1125].Fix(IS_STRUCTURE); -NODES[1126].Fix(IS_STRUCTURE); -NODES[1127].Fix(IS_STRUCTURE); -NODES[1128].Fix(IS_STRUCTURE); -NODES[1129].Fix(IS_STRUCTURE); -NODES[1130].Fix(IS_STRUCTURE); -NODES[1131].Fix(IS_STRUCTURE); -NODES[1132].Fix(IS_STRUCTURE); -NODES[1133].Fix(IS_STRUCTURE); -NODES[1134].Fix(IS_STRUCTURE); -NODES[1135].Fix(IS_STRUCTURE); -NODES[1136].Fix(IS_STRUCTURE); -NODES[1137].Fix(IS_STRUCTURE); -NODES[1138].Fix(IS_STRUCTURE); -NODES[1139].Fix(IS_STRUCTURE); -NODES[1140].Fix(IS_STRUCTURE); -NODES[1141].Fix(IS_STRUCTURE); -NODES[1142].Fix(IS_STRUCTURE); -NODES[1143].Fix(IS_STRUCTURE); -NODES[1144].Fix(IS_STRUCTURE); -NODES[1145].Fix(IS_STRUCTURE); -NODES[1146].Fix(IS_STRUCTURE); -NODES[1147].Fix(IS_STRUCTURE); -NODES[1148].Fix(IS_STRUCTURE); -NODES[1149].Fix(IS_STRUCTURE); -NODES[1150].Fix(IS_STRUCTURE); -NODES[1151].Fix(IS_STRUCTURE); -NODES[1152].Fix(IS_STRUCTURE); -NODES[1153].Fix(IS_STRUCTURE); -NODES[1154].Fix(IS_STRUCTURE); -NODES[1155].Fix(IS_STRUCTURE); -NODES[1156].Fix(IS_STRUCTURE); -NODES[1157].Fix(IS_STRUCTURE); -NODES[1158].Fix(IS_STRUCTURE); -NODES[1159].Fix(IS_STRUCTURE); -NODES[1160].Fix(IS_STRUCTURE); -NODES[1161].Fix(IS_STRUCTURE); -NODES[1162].Fix(IS_STRUCTURE); -NODES[1163].Fix(IS_STRUCTURE); -NODES[1164].Fix(IS_STRUCTURE); -NODES[1165].Fix(IS_STRUCTURE); -NODES[1166].Fix(IS_STRUCTURE); -NODES[1167].Fix(IS_STRUCTURE); -NODES[1168].Fix(IS_STRUCTURE); -NODES[1169].Fix(IS_STRUCTURE); -NODES[1170].Fix(IS_STRUCTURE); -NODES[1171].Fix(IS_STRUCTURE); -NODES[1172].Fix(IS_STRUCTURE); -NODES[1173].Fix(IS_STRUCTURE); -NODES[1174].Fix(IS_STRUCTURE); -NODES[1175].Fix(IS_STRUCTURE); -NODES[1176].Fix(IS_STRUCTURE); -NODES[1177].Fix(IS_STRUCTURE); -NODES[1178].Fix(IS_STRUCTURE); -NODES[1179].Fix(IS_STRUCTURE); -NODES[1180].Fix(IS_STRUCTURE); -NODES[1181].Fix(IS_STRUCTURE); -NODES[1182].Fix(IS_STRUCTURE); -NODES[1183].Fix(IS_STRUCTURE); -NODES[1184].Fix(IS_STRUCTURE); -NODES[1185].Fix(IS_STRUCTURE); -NODES[1186].Fix(IS_STRUCTURE); -NODES[1187].Fix(IS_STRUCTURE); -NODES[1188].Fix(IS_STRUCTURE); -NODES[1189].Fix(IS_STRUCTURE); -NODES[1190].Fix(IS_STRUCTURE); -NODES[1191].Fix(IS_STRUCTURE); -NODES[1192].Fix(IS_STRUCTURE); -NODES[1193].Fix(IS_STRUCTURE); -NODES[1194].Fix(IS_STRUCTURE); -NODES[1195].Fix(IS_STRUCTURE); -NODES[1196].Fix(IS_STRUCTURE); -NODES[1197].Fix(IS_STRUCTURE); -NODES[1198].Fix(IS_STRUCTURE); -NODES[1199].Fix(IS_STRUCTURE); -NODES[1200].Fix(IS_STRUCTURE); -NODES[1201].Fix(IS_STRUCTURE); -NODES[1202].Fix(IS_STRUCTURE); -NODES[1203].Fix(IS_STRUCTURE); -NODES[1204].Fix(IS_STRUCTURE); -NODES[1205].Fix(IS_STRUCTURE); -NODES[1206].Fix(IS_STRUCTURE); -NODES[1207].Fix(IS_STRUCTURE); -NODES[1208].Fix(IS_STRUCTURE); -NODES[1209].Fix(IS_STRUCTURE); -NODES[1210].Fix(IS_STRUCTURE); -NODES[1211].Fix(IS_STRUCTURE); -NODES[1212].Fix(IS_STRUCTURE); -NODES[1213].Fix(IS_STRUCTURE); -NODES[1214].Fix(IS_STRUCTURE); -NODES[1215].Fix(IS_STRUCTURE); -NODES[1216].Fix(IS_STRUCTURE); -NODES[1217].Fix(IS_STRUCTURE); -NODES[1218].Fix(IS_STRUCTURE); -NODES[1219].Fix(IS_STRUCTURE); -NODES[1220].Fix(IS_STRUCTURE); -NODES[1221].Fix(IS_STRUCTURE); -NODES[1222].Fix(IS_STRUCTURE); -NODES[1223].Fix(IS_STRUCTURE); -NODES[1224].Fix(IS_STRUCTURE); -NODES[1225].Fix(IS_STRUCTURE); -NODES[1226].Fix(IS_STRUCTURE); -NODES[1227].Fix(IS_STRUCTURE); -NODES[1228].Fix(IS_STRUCTURE); -NODES[1229].Fix(IS_STRUCTURE); -NODES[1230].Fix(IS_STRUCTURE); -NODES[1231].Fix(IS_STRUCTURE); -NODES[1232].Fix(IS_STRUCTURE); -NODES[1233].Fix(IS_STRUCTURE); -NODES[1234].Fix(IS_STRUCTURE); -NODES[1235].Fix(IS_STRUCTURE); -NODES[1236].Fix(IS_STRUCTURE); -NODES[1237].Fix(IS_STRUCTURE); -NODES[1238].Fix(IS_STRUCTURE); -NODES[1239].Fix(IS_STRUCTURE); -NODES[1240].Fix(IS_STRUCTURE); -NODES[1241].Fix(IS_STRUCTURE); -NODES[1242].Fix(IS_STRUCTURE); -NODES[1243].Fix(IS_STRUCTURE); -NODES[1244].Fix(IS_STRUCTURE); -NODES[1245].Fix(IS_STRUCTURE); -NODES[1246].Fix(IS_STRUCTURE); -NODES[1247].Fix(IS_STRUCTURE); -NODES[1248].Fix(IS_STRUCTURE); -NODES[1249].Fix(IS_STRUCTURE); -NODES[1250].Fix(IS_STRUCTURE); -NODES[1251].Fix(IS_STRUCTURE); -NODES[1252].Fix(IS_STRUCTURE); -NODES[1253].Fix(IS_STRUCTURE); -NODES[1254].Fix(IS_STRUCTURE); -NODES[1255].Fix(IS_STRUCTURE); -NODES[1256].Fix(IS_STRUCTURE); -NODES[1257].Fix(IS_STRUCTURE); -NODES[1258].Fix(IS_STRUCTURE); -NODES[1259].Fix(IS_STRUCTURE); -NODES[1260].Fix(IS_STRUCTURE); -NODES[1261].Fix(IS_STRUCTURE); -NODES[1262].Fix(IS_STRUCTURE); -NODES[1263].Fix(IS_STRUCTURE); -NODES[1264].Fix(IS_STRUCTURE); -NODES[1265].Fix(IS_STRUCTURE); -NODES[1266].Fix(IS_STRUCTURE); -NODES[1267].Fix(IS_STRUCTURE); -NODES[1268].Fix(IS_STRUCTURE); -NODES[1269].Fix(IS_STRUCTURE); -NODES[1270].Fix(IS_STRUCTURE); -NODES[1271].Fix(IS_STRUCTURE); -NODES[1272].Fix(IS_STRUCTURE); -NODES[1273].Fix(IS_STRUCTURE); -NODES[1274].Fix(IS_STRUCTURE); -NODES[1275].Fix(IS_STRUCTURE); -NODES[1276].Fix(IS_STRUCTURE); -NODES[1277].Fix(IS_STRUCTURE); -NODES[1278].Fix(IS_STRUCTURE); -NODES[1279].Fix(IS_STRUCTURE); -NODES[1280].Fix(IS_STRUCTURE); -NODES[1281].Fix(IS_STRUCTURE); -NODES[1282].Fix(IS_STRUCTURE); -NODES[1283].Fix(IS_STRUCTURE); -NODES[1284].Fix(IS_STRUCTURE); -NODES[1285].Fix(IS_STRUCTURE); -NODES[1286].Fix(IS_STRUCTURE); -NODES[1287].Fix(IS_STRUCTURE); -NODES[1288].Fix(IS_STRUCTURE); -NODES[1289].Fix(IS_STRUCTURE); -NODES[1290].Fix(IS_STRUCTURE); -NODES[1291].Fix(IS_STRUCTURE); -NODES[1292].Fix(IS_STRUCTURE); -NODES[1293].Fix(IS_STRUCTURE); -NODES[1294].Fix(IS_STRUCTURE); -NODES[1295].Fix(IS_STRUCTURE); -NODES[1296].Fix(IS_STRUCTURE); -NODES[1297].Fix(IS_STRUCTURE); -NODES[1298].Fix(IS_STRUCTURE); -NODES[1299].Fix(IS_STRUCTURE); -NODES[1300].Fix(IS_STRUCTURE); -NODES[1301].Fix(IS_STRUCTURE); -NODES[1302].Fix(IS_STRUCTURE); -NODES[1303].Fix(IS_STRUCTURE); -NODES[1304].Fix(IS_STRUCTURE); -NODES[1305].Fix(IS_STRUCTURE); -NODES[1306].Fix(IS_STRUCTURE); -NODES[1307].Fix(IS_STRUCTURE); -NODES[1308].Fix(IS_STRUCTURE); -NODES[1309].Fix(IS_STRUCTURE); -NODES[1310].Fix(IS_STRUCTURE); -NODES[1311].Fix(IS_STRUCTURE); -NODES[1312].Fix(IS_STRUCTURE); -NODES[1313].Fix(IS_STRUCTURE); -NODES[1314].Fix(IS_STRUCTURE); -NODES[1315].Fix(IS_STRUCTURE); -NODES[1316].Fix(IS_STRUCTURE); -NODES[1317].Fix(IS_STRUCTURE); -NODES[1318].Fix(IS_STRUCTURE); -NODES[1319].Fix(IS_STRUCTURE); -NODES[1320].Fix(IS_STRUCTURE); -NODES[1321].Fix(IS_STRUCTURE); -NODES[1322].Fix(IS_STRUCTURE); -NODES[1323].Fix(IS_STRUCTURE); -NODES[1324].Fix(IS_STRUCTURE); -NODES[1325].Fix(IS_STRUCTURE); -NODES[1326].Fix(IS_STRUCTURE); -NODES[1327].Fix(IS_STRUCTURE); -NODES[1328].Fix(IS_STRUCTURE); -NODES[1329].Fix(IS_STRUCTURE); -NODES[1330].Fix(IS_STRUCTURE); -NODES[1331].Fix(IS_STRUCTURE); -NODES[1332].Fix(IS_STRUCTURE); -NODES[1333].Fix(IS_STRUCTURE); -NODES[1334].Fix(IS_STRUCTURE); -NODES[1335].Fix(IS_STRUCTURE); -NODES[1336].Fix(IS_STRUCTURE); -NODES[1337].Fix(IS_STRUCTURE); -NODES[1338].Fix(IS_STRUCTURE); -NODES[1339].Fix(IS_STRUCTURE); -NODES[1340].Fix(IS_STRUCTURE); -NODES[1341].Fix(IS_STRUCTURE); -NODES[1342].Fix(IS_STRUCTURE); -NODES[1343].Fix(IS_STRUCTURE); -NODES[1344].Fix(IS_STRUCTURE); -NODES[1345].Fix(IS_STRUCTURE); -NODES[1346].Fix(IS_STRUCTURE); -NODES[1347].Fix(IS_STRUCTURE); -NODES[1348].Fix(IS_STRUCTURE); -NODES[1349].Fix(IS_STRUCTURE); -NODES[1350].Fix(IS_STRUCTURE); -NODES[1351].Fix(IS_STRUCTURE); -NODES[1352].Fix(IS_STRUCTURE); -NODES[1353].Fix(IS_STRUCTURE); -NODES[1354].Fix(IS_STRUCTURE); -NODES[1355].Fix(IS_STRUCTURE); -NODES[1356].Fix(IS_STRUCTURE); -NODES[1357].Fix(IS_STRUCTURE); -NODES[1358].Fix(IS_STRUCTURE); -NODES[1359].Fix(IS_STRUCTURE); -NODES[1360].Fix(IS_STRUCTURE); -NODES[1361].Fix(IS_STRUCTURE); -NODES[1362].Fix(IS_STRUCTURE); -NODES[1363].Fix(IS_STRUCTURE); -NODES[1364].Fix(IS_STRUCTURE); -NODES[1365].Fix(IS_STRUCTURE); -NODES[1366].Fix(IS_STRUCTURE); -NODES[1367].Fix(IS_STRUCTURE); -NODES[1368].Fix(IS_STRUCTURE); -NODES[1369].Fix(IS_STRUCTURE); -NODES[1370].Fix(IS_STRUCTURE); -NODES[1371].Fix(IS_STRUCTURE); -NODES[1372].Fix(IS_STRUCTURE); -NODES[1373].Fix(IS_STRUCTURE); -NODES[1374].Fix(IS_STRUCTURE); -NODES[1375].Fix(IS_STRUCTURE); -NODES[1376].Fix(IS_STRUCTURE); -NODES[1377].Fix(IS_STRUCTURE); -NODES[1378].Fix(IS_STRUCTURE); -NODES[1379].Fix(IS_STRUCTURE); -NODES[1380].Fix(IS_STRUCTURE); -NODES[1381].Fix(IS_STRUCTURE); -NODES[1382].Fix(IS_STRUCTURE); -NODES[1383].Fix(IS_STRUCTURE); -NODES[1384].Fix(IS_STRUCTURE); -NODES[1385].Fix(IS_STRUCTURE); -NODES[1386].Fix(IS_STRUCTURE); -NODES[1387].Fix(IS_STRUCTURE); -NODES[1388].Fix(IS_STRUCTURE); -NODES[1389].Fix(IS_STRUCTURE); -NODES[1390].Fix(IS_STRUCTURE); -NODES[1391].Fix(IS_STRUCTURE); -NODES[1392].Fix(IS_STRUCTURE); -NODES[1393].Fix(IS_STRUCTURE); -NODES[1394].Fix(IS_STRUCTURE); -NODES[1395].Fix(IS_STRUCTURE); -NODES[1396].Fix(IS_STRUCTURE); -NODES[1397].Fix(IS_STRUCTURE); -NODES[1398].Fix(IS_STRUCTURE); -NODES[1399].Fix(IS_STRUCTURE); -NODES[1400].Fix(IS_STRUCTURE); -NODES[1401].Fix(IS_STRUCTURE); -NODES[1402].Fix(IS_STRUCTURE); -NODES[1403].Fix(IS_STRUCTURE); -NODES[1404].Fix(IS_STRUCTURE); -NODES[1405].Fix(IS_STRUCTURE); -NODES[1406].Fix(IS_STRUCTURE); -NODES[1407].Fix(IS_STRUCTURE); -NODES[1408].Fix(IS_STRUCTURE); -NODES[1409].Fix(IS_STRUCTURE); -NODES[1410].Fix(IS_STRUCTURE); -NODES[1411].Fix(IS_STRUCTURE); -NODES[1412].Fix(IS_STRUCTURE); -NODES[1413].Fix(IS_STRUCTURE); -NODES[1414].Fix(IS_STRUCTURE); -NODES[1415].Fix(IS_STRUCTURE); -NODES[1416].Fix(IS_STRUCTURE); -NODES[1417].Fix(IS_STRUCTURE); -NODES[1418].Fix(IS_STRUCTURE); -NODES[1419].Fix(IS_STRUCTURE); -NODES[1420].Fix(IS_STRUCTURE); -NODES[1421].Fix(IS_STRUCTURE); -NODES[1422].Fix(IS_STRUCTURE); -NODES[1423].Fix(IS_STRUCTURE); -NODES[1424].Fix(IS_STRUCTURE); -NODES[1425].Fix(IS_STRUCTURE); -NODES[1426].Fix(IS_STRUCTURE); -NODES[1427].Fix(IS_STRUCTURE); -NODES[1428].Fix(IS_STRUCTURE); -NODES[1429].Fix(IS_STRUCTURE); -NODES[1430].Fix(IS_STRUCTURE); -NODES[1431].Fix(IS_STRUCTURE); -NODES[1432].Fix(IS_STRUCTURE); -NODES[1433].Fix(IS_STRUCTURE); -NODES[1434].Fix(IS_STRUCTURE); -NODES[1435].Fix(IS_STRUCTURE); -NODES[1436].Fix(IS_STRUCTURE); -NODES[1437].Fix(IS_STRUCTURE); -NODES[1438].Fix(IS_STRUCTURE); -NODES[1439].Fix(IS_STRUCTURE); -NODES[1440].Fix(IS_STRUCTURE); -NODES[1441].Fix(IS_STRUCTURE); -NODES[1442].Fix(IS_STRUCTURE); -NODES[1443].Fix(IS_STRUCTURE); -NODES[1444].Fix(IS_STRUCTURE); -NODES[1445].Fix(IS_STRUCTURE); -NODES[1446].Fix(IS_STRUCTURE); -NODES[1447].Fix(IS_STRUCTURE); -NODES[1448].Fix(IS_STRUCTURE); -NODES[1449].Fix(IS_STRUCTURE); -NODES[1450].Fix(IS_STRUCTURE); -NODES[1451].Fix(IS_STRUCTURE); -NODES[1452].Fix(IS_STRUCTURE); -NODES[1453].Fix(IS_STRUCTURE); -NODES[1454].Fix(IS_STRUCTURE); -NODES[1455].Fix(IS_STRUCTURE); -NODES[1456].Fix(IS_STRUCTURE); -NODES[1457].Fix(IS_STRUCTURE); -NODES[1458].Fix(IS_STRUCTURE); -NODES[1459].Fix(IS_STRUCTURE); -NODES[1460].Fix(IS_STRUCTURE); -NODES[1461].Fix(IS_STRUCTURE); -NODES[1462].Fix(IS_STRUCTURE); -NODES[1463].Fix(IS_STRUCTURE); -NODES[1464].Fix(IS_STRUCTURE); -NODES[1465].Fix(IS_STRUCTURE); -NODES[1466].Fix(IS_STRUCTURE); -NODES[1467].Fix(IS_STRUCTURE); -NODES[1468].Fix(IS_STRUCTURE); -NODES[1469].Fix(IS_STRUCTURE); -NODES[1470].Fix(IS_STRUCTURE); -NODES[1471].Fix(IS_STRUCTURE); -NODES[1472].Fix(IS_STRUCTURE); -NODES[1473].Fix(IS_STRUCTURE); -NODES[1474].Fix(IS_STRUCTURE); -NODES[1475].Fix(IS_STRUCTURE); -NODES[1476].Fix(IS_STRUCTURE); -NODES[1477].Fix(IS_STRUCTURE); -NODES[1478].Fix(IS_STRUCTURE); -NODES[1479].Fix(IS_STRUCTURE); -NODES[1480].Fix(IS_STRUCTURE); -NODES[1481].Fix(IS_STRUCTURE); -NODES[1482].Fix(IS_STRUCTURE); -NODES[1483].Fix(IS_STRUCTURE); -NODES[1484].Fix(IS_STRUCTURE); -NODES[1485].Fix(IS_STRUCTURE); -NODES[1486].Fix(IS_STRUCTURE); -NODES[1487].Fix(IS_STRUCTURE); -NODES[1488].Fix(IS_STRUCTURE); -NODES[1489].Fix(IS_STRUCTURE); -NODES[1490].Fix(IS_STRUCTURE); -NODES[1491].Fix(IS_STRUCTURE); -NODES[1492].Fix(IS_STRUCTURE); -NODES[1493].Fix(IS_STRUCTURE); -NODES[1494].Fix(IS_STRUCTURE); -NODES[1495].Fix(IS_STRUCTURE); -NODES[1496].Fix(IS_STRUCTURE); -NODES[1497].Fix(IS_STRUCTURE); -NODES[1498].Fix(IS_STRUCTURE); -NODES[1499].Fix(IS_STRUCTURE); -NODES[1500].Fix(IS_STRUCTURE); -NODES[1501].Fix(IS_STRUCTURE); -NODES[1502].Fix(IS_STRUCTURE); -NODES[1503].Fix(IS_STRUCTURE); -NODES[1504].Fix(IS_STRUCTURE); -NODES[1505].Fix(IS_STRUCTURE); -NODES[1506].Fix(IS_STRUCTURE); -NODES[1507].Fix(IS_STRUCTURE); -NODES[1508].Fix(IS_STRUCTURE); -NODES[1509].Fix(IS_STRUCTURE); -NODES[1510].Fix(IS_STRUCTURE); -NODES[1511].Fix(IS_STRUCTURE); -NODES[1512].Fix(IS_STRUCTURE); -NODES[1513].Fix(IS_STRUCTURE); -NODES[1514].Fix(IS_STRUCTURE); -NODES[1515].Fix(IS_STRUCTURE); -NODES[1516].Fix(IS_STRUCTURE); -NODES[1517].Fix(IS_STRUCTURE); -NODES[1518].Fix(IS_STRUCTURE); -NODES[1519].Fix(IS_STRUCTURE); -NODES[1520].Fix(IS_STRUCTURE); -NODES[1521].Fix(IS_STRUCTURE); -NODES[1522].Fix(IS_STRUCTURE); -NODES[1523].Fix(IS_STRUCTURE); -NODES[1524].Fix(IS_STRUCTURE); -NODES[1525].Fix(IS_STRUCTURE); -NODES[1526].Fix(IS_STRUCTURE); -NODES[1527].Fix(IS_STRUCTURE); -NODES[1528].Fix(IS_STRUCTURE); -NODES[1529].Fix(IS_STRUCTURE); -NODES[1530].Fix(IS_STRUCTURE); -NODES[1531].Fix(IS_STRUCTURE); -NODES[1532].Fix(IS_STRUCTURE); -NODES[1533].Fix(IS_STRUCTURE); -NODES[1534].Fix(IS_STRUCTURE); -NODES[1535].Fix(IS_STRUCTURE); -NODES[1536].Fix(IS_STRUCTURE); -NODES[1537].Fix(IS_STRUCTURE); -NODES[1538].Fix(IS_STRUCTURE); -NODES[1539].Fix(IS_STRUCTURE); -NODES[1540].Fix(IS_STRUCTURE); -NODES[1541].Fix(IS_STRUCTURE); -NODES[1542].Fix(IS_STRUCTURE); -NODES[1544].Fix(IS_STRUCTURE); -NODES[1545].Fix(IS_STRUCTURE); -NODES[1547].Fix(IS_STRUCTURE); -NODES[1548].Fix(IS_STRUCTURE); -NODES[1549].Fix(IS_STRUCTURE); -NODES[1550].Fix(IS_STRUCTURE); -NODES[1551].Fix(IS_STRUCTURE); -NODES[1552].Fix(IS_STRUCTURE); -NODES[1554].Fix(IS_STRUCTURE); -NODES[1555].Fix(IS_STRUCTURE); -NODES[1556].Fix(IS_STRUCTURE); -NODES[1557].Fix(IS_STRUCTURE); -NODES[1558].Fix(IS_STRUCTURE); -NODES[1559].Fix(IS_STRUCTURE); -NODES[1560].Fix(IS_STRUCTURE); -NODES[1561].Fix(IS_STRUCTURE); -NODES[1562].Fix(IS_STRUCTURE); -NODES[1564].Fix(IS_STRUCTURE); -NODES[1565].Fix(IS_STRUCTURE); -NODES[1566].Fix(IS_STRUCTURE); -NODES[1567].Fix(IS_STRUCTURE); -NODES[1568].Fix(IS_STRUCTURE); -NODES[1569].Fix(IS_STRUCTURE); -NODES[1570].Fix(IS_STRUCTURE); -NODES[1571].Fix(IS_STRUCTURE); -NODES[1572].Fix(IS_STRUCTURE); -NODES[1573].Fix(IS_STRUCTURE); -NODES[1574].Fix(IS_STRUCTURE); -NODES[1576].Fix(IS_STRUCTURE); -NODES[1577].Fix(IS_STRUCTURE); -NODES[1578].Fix(IS_STRUCTURE); -NODES[1579].Fix(IS_STRUCTURE); -NODES[1580].Fix(IS_STRUCTURE); -NODES[1581].Fix(IS_STRUCTURE); -NODES[1582].Fix(IS_STRUCTURE); -NODES[1583].Fix(IS_STRUCTURE); -NODES[1584].Fix(IS_STRUCTURE); -NODES[1585].Fix(IS_STRUCTURE); -NODES[1586].Fix(IS_STRUCTURE); -NODES[1587].Fix(IS_STRUCTURE); -NODES[1588].Fix(IS_STRUCTURE); -NODES[1589].Fix(IS_STRUCTURE); -NODES[1590].Fix(IS_STRUCTURE); -NODES[1591].Fix(IS_STRUCTURE); -NODES[1592].Fix(IS_STRUCTURE); -NODES[1594].Fix(IS_STRUCTURE); -NODES[1595].Fix(IS_STRUCTURE); -NODES[1596].Fix(IS_STRUCTURE); -NODES[1597].Fix(IS_STRUCTURE); -NODES[1598].Fix(IS_STRUCTURE); -NODES[1599].Fix(IS_STRUCTURE); -NODES[1600].Fix(IS_STRUCTURE); -NODES[1601].Fix(IS_STRUCTURE); -NODES[1602].Fix(IS_STRUCTURE); -NODES[1603].Fix(IS_STRUCTURE); -NODES[1604].Fix(IS_STRUCTURE); -NODES[1605].Fix(IS_STRUCTURE); -NODES[1607].Fix(IS_STRUCTURE); -NODES[1608].Fix(IS_STRUCTURE); -NODES[1609].Fix(IS_STRUCTURE); -NODES[1611].Fix(IS_STRUCTURE); -NODES[1612].Fix(IS_STRUCTURE); -NODES[1614].Fix(IS_STRUCTURE); -NODES[1615].Fix(IS_STRUCTURE); -NODES[1617].Fix(IS_STRUCTURE); -NODES[1619].Fix(IS_STRUCTURE); -NODES[1620].Fix(IS_STRUCTURE); -NODES[1622].Fix(IS_STRUCTURE); -NODES[1623].Fix(IS_STRUCTURE); -NODES[1624].Fix(IS_STRUCTURE); -NODES[1626].Fix(IS_STRUCTURE); -NODES[1627].Fix(IS_STRUCTURE); -NODES[1628].Fix(IS_STRUCTURE); -NODES[1629].Fix(IS_STRUCTURE); -NODES[1630].Fix(IS_STRUCTURE); -NODES[1631].Fix(IS_STRUCTURE); -NODES[1632].Fix(IS_STRUCTURE); -NODES[1633].Fix(IS_STRUCTURE); -NODES[1634].Fix(IS_STRUCTURE); -NODES[1635].Fix(IS_STRUCTURE); -NODES[1636].Fix(IS_STRUCTURE); -NODES[1637].Fix(IS_STRUCTURE); -NODES[1638].Fix(IS_STRUCTURE); -NODES[1640].Fix(IS_STRUCTURE); -NODES[1642].Fix(IS_STRUCTURE); -NODES[1643].Fix(IS_STRUCTURE); -NODES[1645].Fix(IS_STRUCTURE); -NODES[1646].Fix(IS_STRUCTURE); -NODES[1647].Fix(IS_STRUCTURE); -NODES[1648].Fix(IS_STRUCTURE); -NODES[1649].Fix(IS_STRUCTURE); -NODES[1650].Fix(IS_STRUCTURE); -NODES[1651].Fix(IS_STRUCTURE); -NODES[1652].Fix(IS_STRUCTURE); -NODES[1653].Fix(IS_STRUCTURE); -NODES[1654].Fix(IS_STRUCTURE); -NODES[1655].Fix(IS_STRUCTURE); -NODES[1656].Fix(IS_STRUCTURE); -NODES[1657].Fix(IS_STRUCTURE); -NODES[1658].Fix(IS_STRUCTURE); -NODES[1661].Fix(IS_STRUCTURE); -NODES[1662].Fix(IS_STRUCTURE); -NODES[1663].Fix(IS_STRUCTURE); -NODES[1665].Fix(IS_STRUCTURE); -NODES[1666].Fix(IS_STRUCTURE); -NODES[1667].Fix(IS_STRUCTURE); -NODES[1668].Fix(IS_STRUCTURE); -NODES[1669].Fix(IS_STRUCTURE); -NODES[1670].Fix(IS_STRUCTURE); -NODES[1672].Fix(IS_STRUCTURE); -NODES[1673].Fix(IS_STRUCTURE); -NODES[1674].Fix(IS_STRUCTURE); -NODES[1675].Fix(IS_STRUCTURE); -NODES[1676].Fix(IS_STRUCTURE); -NODES[1678].Fix(IS_STRUCTURE); -NODES[1679].Fix(IS_STRUCTURE); -NODES[1682].Fix(IS_STRUCTURE); -NODES[1683].Fix(IS_STRUCTURE); -NODES[1684].Fix(IS_STRUCTURE); -NODES[1685].Fix(IS_STRUCTURE); -NODES[1686].Fix(IS_STRUCTURE); -NODES[1687].Fix(IS_STRUCTURE); -NODES[1688].Fix(IS_STRUCTURE); -NODES[1689].Fix(IS_STRUCTURE); -NODES[1690].Fix(IS_STRUCTURE); -NODES[1691].Fix(IS_STRUCTURE); -NODES[1692].Fix(IS_STRUCTURE); -NODES[1694].Fix(IS_STRUCTURE); -NODES[1695].Fix(IS_STRUCTURE); -NODES[1696].Fix(IS_STRUCTURE); -NODES[1699].Fix(IS_STRUCTURE); -NODES[1700].Fix(IS_STRUCTURE); -NODES[1701].Fix(IS_STRUCTURE); -NODES[1703].Fix(IS_STRUCTURE); -NODES[1704].Fix(IS_STRUCTURE); -NODES[1707].Fix(IS_STRUCTURE); -NODES[1708].Fix(IS_STRUCTURE); -NODES[1709].Fix(IS_STRUCTURE); -NODES[1710].Fix(IS_STRUCTURE); -NODES[1714].Fix(IS_STRUCTURE); -NODES[1716].Fix(IS_STRUCTURE); -NODES[1718].Fix(IS_STRUCTURE); -NODES[1719].Fix(IS_STRUCTURE); -NODES[1720].Fix(IS_STRUCTURE); -NODES[1724].Fix(IS_STRUCTURE); -NODES[1725].Fix(IS_STRUCTURE); -NODES[1726].Fix(IS_STRUCTURE); -NODES[1730].Fix(IS_STRUCTURE); -NODES[1731].Fix(IS_STRUCTURE); -NODES[1732].Fix(IS_STRUCTURE); -NODES[1733].Fix(IS_STRUCTURE); -NODES[1734].Fix(IS_STRUCTURE); -NODES[1735].Fix(IS_STRUCTURE); -NODES[1736].Fix(IS_STRUCTURE); -NODES[1737].Fix(IS_STRUCTURE); -NODES[1738].Fix(IS_STRUCTURE); -NODES[1741].Fix(IS_STRUCTURE); -NODES[1742].Fix(IS_STRUCTURE); -NODES[1743].Fix(IS_STRUCTURE); -NODES[1745].Fix(IS_STRUCTURE); -NODES[1747].Fix(IS_STRUCTURE); -NODES[1748].Fix(IS_STRUCTURE); -NODES[1749].Fix(IS_STRUCTURE); -NODES[1750].Fix(IS_STRUCTURE); -NODES[1753].Fix(IS_STRUCTURE); -NODES[1754].Fix(IS_STRUCTURE); -NODES[1755].Fix(IS_STRUCTURE); -NODES[1757].Fix(IS_STRUCTURE); -NODES[1758].Fix(IS_STRUCTURE); -NODES[1760].Fix(IS_STRUCTURE); -NODES[1761].Fix(IS_STRUCTURE); -NODES[1762].Fix(IS_STRUCTURE); -NODES[1763].Fix(IS_STRUCTURE); -NODES[1764].Fix(IS_STRUCTURE); -NODES[1765].Fix(IS_STRUCTURE); -NODES[1766].Fix(IS_STRUCTURE); -NODES[1768].Fix(IS_STRUCTURE); -NODES[1769].Fix(IS_STRUCTURE); -NODES[1770].Fix(IS_STRUCTURE); -NODES[1771].Fix(IS_STRUCTURE); -NODES[1772].Fix(IS_STRUCTURE); -NODES[1773].Fix(IS_STRUCTURE); -NODES[1774].Fix(IS_STRUCTURE); -NODES[1775].Fix(IS_STRUCTURE); -NODES[1776].Fix(IS_STRUCTURE); -NODES[1777].Fix(IS_STRUCTURE); -NODES[1778].Fix(IS_STRUCTURE); -NODES[1779].Fix(IS_STRUCTURE); -NODES[1780].Fix(IS_STRUCTURE); -NODES[1781].Fix(IS_STRUCTURE); -NODES[1784].Fix(IS_STRUCTURE); -NODES[1787].Fix(IS_STRUCTURE); -NODES[1788].Fix(IS_STRUCTURE); -NODES[1790].Fix(IS_STRUCTURE); -NODES[1792].Fix(IS_STRUCTURE); -NODES[1793].Fix(IS_STRUCTURE); -NODES[1794].Fix(IS_STRUCTURE); -NODES[1796].Fix(IS_STRUCTURE); -NODES[1797].Fix(IS_STRUCTURE); -NODES[1798].Fix(IS_STRUCTURE); -NODES[1799].Fix(IS_STRUCTURE); -NODES[1800].Fix(IS_STRUCTURE); -NODES[1805].Fix(IS_STRUCTURE); -NODES[1806].Fix(IS_STRUCTURE); -NODES[1810].Fix(IS_STRUCTURE); -NODES[1813].Fix(IS_STRUCTURE); -NODES[1815].Fix(IS_STRUCTURE); -NODES[1817].Fix(IS_STRUCTURE); -NODES[1819].Fix(IS_STRUCTURE); -NODES[1820].Fix(IS_STRUCTURE); -NODES[1822].Fix(IS_STRUCTURE); -NODES[1824].Fix(IS_STRUCTURE); -NODES[1825].Fix(IS_STRUCTURE); -NODES[1826].Fix(IS_STRUCTURE); -NODES[1827].Fix(IS_STRUCTURE); -NODES[1830].Fix(IS_STRUCTURE); -NODES[1834].Fix(IS_STRUCTURE); -NODES[1835].Fix(IS_STRUCTURE); -NODES[1837].Fix(IS_STRUCTURE); -NODES[1838].Fix(IS_STRUCTURE); -NODES[1841].Fix(IS_STRUCTURE); -NODES[1842].Fix(IS_STRUCTURE); -NODES[1843].Fix(IS_STRUCTURE); -NODES[1844].Fix(IS_STRUCTURE); -NODES[1845].Fix(IS_STRUCTURE); -NODES[1847].Fix(IS_STRUCTURE); -NODES[1850].Fix(IS_STRUCTURE); -NODES[1851].Fix(IS_STRUCTURE); -NODES[1852].Fix(IS_STRUCTURE); -NODES[1853].Fix(IS_STRUCTURE); -NODES[1855].Fix(IS_STRUCTURE); -NODES[1857].Fix(IS_STRUCTURE); -NODES[1858].Fix(IS_STRUCTURE); -NODES[1859].Fix(IS_STRUCTURE); -NODES[1860].Fix(IS_STRUCTURE); -NODES[1863].Fix(IS_STRUCTURE); -NODES[1864].Fix(IS_STRUCTURE); -NODES[1865].Fix(IS_STRUCTURE); -NODES[1866].Fix(IS_STRUCTURE); -NODES[1867].Fix(IS_STRUCTURE); -NODES[1871].Fix(IS_STRUCTURE); -NODES[1877].Fix(IS_STRUCTURE); -NODES[1882].Fix(IS_STRUCTURE); -NODES[1883].Fix(IS_STRUCTURE); -NODES[1884].Fix(IS_STRUCTURE); -NODES[1886].Fix(IS_STRUCTURE); -NODES[1890].Fix(IS_STRUCTURE); -NODES[1891].Fix(IS_STRUCTURE); -NODES[1892].Fix(IS_STRUCTURE); -NODES[1894].Fix(IS_STRUCTURE); -NODES[1895].Fix(IS_STRUCTURE); -NODES[1896].Fix(IS_STRUCTURE); -NODES[1898].Fix(IS_STRUCTURE); -NODES[1899].Fix(IS_STRUCTURE); -NODES[1900].Fix(IS_STRUCTURE); -NODES[1901].Fix(IS_STRUCTURE); -NODES[1902].Fix(IS_STRUCTURE); -NODES[1903].Fix(IS_STRUCTURE); -NODES[1904].Fix(IS_STRUCTURE); -NODES[1905].Fix(IS_STRUCTURE); -NODES[1908].Fix(IS_STRUCTURE); -NODES[1909].Fix(IS_STRUCTURE); -NODES[1912].Fix(IS_STRUCTURE); -NODES[1914].Fix(IS_STRUCTURE); -NODES[1918].Fix(IS_STRUCTURE); -NODES[1920].Fix(IS_STRUCTURE); -NODES[1921].Fix(IS_STRUCTURE); -NODES[1923].Fix(IS_STRUCTURE); -NODES[1925].Fix(IS_STRUCTURE); -NODES[1926].Fix(IS_STRUCTURE); -NODES[1927].Fix(IS_STRUCTURE); -NODES[1929].Fix(IS_STRUCTURE); -NODES[1930].Fix(IS_STRUCTURE); -NODES[1934].Fix(IS_STRUCTURE); -NODES[1935].Fix(IS_STRUCTURE); -NODES[1936].Fix(IS_STRUCTURE); -NODES[1937].Fix(IS_STRUCTURE); -NODES[1940].Fix(IS_STRUCTURE); -NODES[1943].Fix(IS_STRUCTURE); -NODES[1944].Fix(IS_STRUCTURE); -NODES[1945].Fix(IS_STRUCTURE); -NODES[1946].Fix(IS_STRUCTURE); -NODES[1947].Fix(IS_STRUCTURE); -NODES[1950].Fix(IS_STRUCTURE); -NODES[1951].Fix(IS_STRUCTURE); -NODES[1953].Fix(IS_STRUCTURE); -NODES[1954].Fix(IS_STRUCTURE); -NODES[1957].Fix(IS_STRUCTURE); -NODES[1962].Fix(IS_STRUCTURE); -NODES[1963].Fix(IS_STRUCTURE); -NODES[1965].Fix(IS_STRUCTURE); -NODES[1968].Fix(IS_STRUCTURE); -NODES[1970].Fix(IS_STRUCTURE); -NODES[1971].Fix(IS_STRUCTURE); -NODES[1974].Fix(IS_STRUCTURE); -NODES[1979].Fix(IS_STRUCTURE); -NODES[1980].Fix(IS_STRUCTURE); -NODES[1981].Fix(IS_STRUCTURE); -NODES[1982].Fix(IS_STRUCTURE); -NODES[1983].Fix(IS_STRUCTURE); -NODES[1984].Fix(IS_STRUCTURE); -NODES[1986].Fix(IS_STRUCTURE); -NODES[1988].Fix(IS_STRUCTURE); -NODES[1990].Fix(IS_STRUCTURE); -NODES[1991].Fix(IS_STRUCTURE); -NODES[1993].Fix(IS_STRUCTURE); -NODES[1994].Fix(IS_STRUCTURE); -NODES[1996].Fix(IS_STRUCTURE); -NODES[1998].Fix(IS_STRUCTURE); -NODES[2000].Fix(IS_STRUCTURE); -NODES[2003].Fix(IS_STRUCTURE); -NODES[2004].Fix(IS_STRUCTURE); -NODES[2005].Fix(IS_STRUCTURE); -NODES[2011].Fix(IS_STRUCTURE); -NODES[2014].Fix(IS_STRUCTURE); -NODES[2015].Fix(IS_STRUCTURE); -NODES[2016].Fix(IS_STRUCTURE); -NODES[2017].Fix(IS_STRUCTURE); -NODES[2020].Fix(IS_STRUCTURE); -NODES[2023].Fix(IS_STRUCTURE); -NODES[2024].Fix(IS_STRUCTURE); -NODES[2029].Fix(IS_STRUCTURE); -NODES[2031].Fix(IS_STRUCTURE); -NODES[2035].Fix(IS_STRUCTURE); -NODES[2036].Fix(IS_STRUCTURE); -NODES[2039].Fix(IS_STRUCTURE); -NODES[2040].Fix(IS_STRUCTURE); -NODES[2042].Fix(IS_STRUCTURE); -NODES[2044].Fix(IS_STRUCTURE); -NODES[2048].Fix(IS_STRUCTURE); -NODES[2049].Fix(IS_STRUCTURE); -NODES[2050].Fix(IS_STRUCTURE); -NODES[2053].Fix(IS_STRUCTURE); -NODES[2055].Fix(IS_STRUCTURE); -NODES[2059].Fix(IS_STRUCTURE); -NODES[2063].Fix(IS_STRUCTURE); -NODES[2067].Fix(IS_STRUCTURE); -NODES[2068].Fix(IS_STRUCTURE); -NODES[2069].Fix(IS_STRUCTURE); -NODES[2070].Fix(IS_STRUCTURE); -NODES[2073].Fix(IS_STRUCTURE); -NODES[2077].Fix(IS_STRUCTURE); -NODES[2082].Fix(IS_STRUCTURE); -NODES[2084].Fix(IS_STRUCTURE); -NODES[2085].Fix(IS_STRUCTURE); -NODES[2088].Fix(IS_STRUCTURE); -NODES[2089].Fix(IS_STRUCTURE); -NODES[2090].Fix(IS_STRUCTURE); -NODES[2091].Fix(IS_STRUCTURE); -NODES[2093].Fix(IS_STRUCTURE); -NODES[2095].Fix(IS_STRUCTURE); -NODES[2097].Fix(IS_STRUCTURE); -NODES[2100].Fix(IS_STRUCTURE); -NODES[2101].Fix(IS_STRUCTURE); -NODES[2102].Fix(IS_STRUCTURE); -NODES[2103].Fix(IS_STRUCTURE); -NODES[2104].Fix(IS_STRUCTURE); -NODES[2105].Fix(IS_STRUCTURE); -NODES[2107].Fix(IS_STRUCTURE); -NODES[2110].Fix(IS_STRUCTURE); -NODES[2111].Fix(IS_STRUCTURE); -NODES[2112].Fix(IS_STRUCTURE); -NODES[2113].Fix(IS_STRUCTURE); -NODES[2115].Fix(IS_STRUCTURE); -NODES[2117].Fix(IS_STRUCTURE); -NODES[2119].Fix(IS_STRUCTURE); -NODES[2120].Fix(IS_STRUCTURE); -NODES[2121].Fix(IS_STRUCTURE); -NODES[2125].Fix(IS_STRUCTURE); -NODES[2127].Fix(IS_STRUCTURE); -NODES[2128].Fix(IS_STRUCTURE); -NODES[2129].Fix(IS_STRUCTURE); -NODES[2131].Fix(IS_STRUCTURE); -NODES[2133].Fix(IS_STRUCTURE); -NODES[2136].Fix(IS_STRUCTURE); -NODES[2138].Fix(IS_STRUCTURE); -NODES[2139].Fix(IS_STRUCTURE); -NODES[2140].Fix(IS_STRUCTURE); -NODES[2145].Fix(IS_STRUCTURE); -NODES[2148].Fix(IS_STRUCTURE); -NODES[2149].Fix(IS_STRUCTURE); -NODES[2150].Fix(IS_STRUCTURE); -NODES[2153].Fix(IS_STRUCTURE); -NODES[2155].Fix(IS_STRUCTURE); -NODES[2158].Fix(IS_STRUCTURE); -NODES[2159].Fix(IS_STRUCTURE); -NODES[2161].Fix(IS_STRUCTURE); -NODES[2164].Fix(IS_STRUCTURE); -NODES[2165].Fix(IS_STRUCTURE); -NODES[2168].Fix(IS_STRUCTURE); -NODES[2169].Fix(IS_STRUCTURE); -NODES[2172].Fix(IS_STRUCTURE); -NODES[2176].Fix(IS_STRUCTURE); -NODES[2177].Fix(IS_STRUCTURE); -NODES[2180].Fix(IS_STRUCTURE); -NODES[2181].Fix(IS_STRUCTURE); -NODES[2183].Fix(IS_STRUCTURE); -NODES[2184].Fix(IS_STRUCTURE); -NODES[2189].Fix(IS_STRUCTURE); -NODES[2190].Fix(IS_STRUCTURE); -NODES[2191].Fix(IS_STRUCTURE); -NODES[2192].Fix(IS_STRUCTURE); -NODES[2195].Fix(IS_STRUCTURE); -NODES[2202].Fix(IS_STRUCTURE); -NODES[2205].Fix(IS_STRUCTURE); -NODES[2208].Fix(IS_STRUCTURE); -NODES[2209].Fix(IS_STRUCTURE); -NODES[2216].Fix(IS_STRUCTURE); -NODES[2217].Fix(IS_STRUCTURE); -NODES[2218].Fix(IS_STRUCTURE); -NODES[2225].Fix(IS_STRUCTURE); -NODES[2227].Fix(IS_STRUCTURE); -NODES[2230].Fix(IS_STRUCTURE); -NODES[2231].Fix(IS_STRUCTURE); -NODES[2236].Fix(IS_STRUCTURE); -NODES[2238].Fix(IS_STRUCTURE); -NODES[2242].Fix(IS_STRUCTURE); -NODES[2244].Fix(IS_STRUCTURE); -NODES[2246].Fix(IS_STRUCTURE); -NODES[2247].Fix(IS_STRUCTURE); -NODES[2251].Fix(IS_STRUCTURE); -NODES[2255].Fix(IS_STRUCTURE); -NODES[2265].Fix(IS_STRUCTURE); -NODES[2268].Fix(IS_STRUCTURE); -NODES[2274].Fix(IS_STRUCTURE); -NODES[2277].Fix(IS_STRUCTURE); -NODES[2278].Fix(IS_STRUCTURE); -NODES[2284].Fix(IS_STRUCTURE); -NODES[2285].Fix(IS_STRUCTURE); -NODES[2286].Fix(IS_STRUCTURE); -NODES[2293].Fix(IS_STRUCTURE); -NODES[2295].Fix(IS_STRUCTURE); -NODES[2297].Fix(IS_STRUCTURE); -NODES[2299].Fix(IS_STRUCTURE); -NODES[2302].Fix(IS_STRUCTURE); -NODES[2303].Fix(IS_STRUCTURE); -NODES[2304].Fix(IS_STRUCTURE); -NODES[2305].Fix(IS_STRUCTURE); -NODES[2306].Fix(IS_STRUCTURE); -NODES[2307].Fix(IS_STRUCTURE); -NODES[2308].Fix(IS_STRUCTURE); -NODES[2309].Fix(IS_STRUCTURE); -NODES[2315].Fix(IS_STRUCTURE); -NODES[2316].Fix(IS_STRUCTURE); -NODES[2321].Fix(IS_STRUCTURE); -NODES[2323].Fix(IS_STRUCTURE); -NODES[2324].Fix(IS_STRUCTURE); -NODES[2325].Fix(IS_STRUCTURE); -NODES[2328].Fix(IS_STRUCTURE); -NODES[2329].Fix(IS_STRUCTURE); -NODES[2330].Fix(IS_STRUCTURE); -NODES[2331].Fix(IS_STRUCTURE); -NODES[2332].Fix(IS_STRUCTURE); -NODES[2333].Fix(IS_STRUCTURE); -NODES[2335].Fix(IS_STRUCTURE); -NODES[2336].Fix(IS_STRUCTURE); -NODES[2345].Fix(IS_STRUCTURE); -NODES[2347].Fix(IS_STRUCTURE); -NODES[2348].Fix(IS_STRUCTURE); -NODES[2351].Fix(IS_STRUCTURE); -NODES[2356].Fix(IS_STRUCTURE); -NODES[2358].Fix(IS_STRUCTURE); -NODES[2359].Fix(IS_STRUCTURE); -NODES[2360].Fix(IS_STRUCTURE); -NODES[2361].Fix(IS_STRUCTURE); -NODES[2362].Fix(IS_STRUCTURE); -NODES[2363].Fix(IS_STRUCTURE); -NODES[2369].Fix(IS_STRUCTURE); -NODES[2370].Fix(IS_STRUCTURE); -NODES[2371].Fix(IS_STRUCTURE); -NODES[2375].Fix(IS_STRUCTURE); -NODES[2376].Fix(IS_STRUCTURE); -NODES[2377].Fix(IS_STRUCTURE); -NODES[2382].Fix(IS_STRUCTURE); -NODES[2388].Fix(IS_STRUCTURE); -NODES[2392].Fix(IS_STRUCTURE); -NODES[2393].Fix(IS_STRUCTURE); -NODES[2395].Fix(IS_STRUCTURE); -NODES[2397].Fix(IS_STRUCTURE); -NODES[2399].Fix(IS_STRUCTURE); -NODES[2405].Fix(IS_STRUCTURE); -NODES[2411].Fix(IS_STRUCTURE); -NODES[2412].Fix(IS_STRUCTURE); -NODES[2418].Fix(IS_STRUCTURE); -NODES[2424].Fix(IS_STRUCTURE); -NODES[2428].Fix(IS_STRUCTURE); -NODES[2429].Fix(IS_STRUCTURE); -NODES[2430].Fix(IS_STRUCTURE); -NODES[2434].Fix(IS_STRUCTURE); -NODES[2435].Fix(IS_STRUCTURE); -NODES[2443].Fix(IS_STRUCTURE); -NODES[2446].Fix(IS_STRUCTURE); -NODES[2452].Fix(IS_STRUCTURE); -NODES[2457].Fix(IS_STRUCTURE); -NODES[2458].Fix(IS_STRUCTURE); -NODES[2459].Fix(IS_STRUCTURE); -NODES[2461].Fix(IS_STRUCTURE); -NODES[2462].Fix(IS_STRUCTURE); -NODES[2470].Fix(IS_STRUCTURE); -NODES[2472].Fix(IS_STRUCTURE); -NODES[2473].Fix(IS_STRUCTURE); -NODES[2478].Fix(IS_STRUCTURE); -NODES[2479].Fix(IS_STRUCTURE); -NODES[2488].Fix(IS_STRUCTURE); -NODES[2489].Fix(IS_STRUCTURE); -NODES[2492].Fix(IS_STRUCTURE); -NODES[2499].Fix(IS_STRUCTURE); -NODES[2505].Fix(IS_STRUCTURE); -NODES[2506].Fix(IS_STRUCTURE); -NODES[2508].Fix(IS_STRUCTURE); -NODES[2510].Fix(IS_STRUCTURE); -NODES[2513].Fix(IS_STRUCTURE); -NODES[2515].Fix(IS_STRUCTURE); -NODES[2519].Fix(IS_STRUCTURE); -NODES[2521].Fix(IS_STRUCTURE); -NODES[2525].Fix(IS_STRUCTURE); -NODES[2526].Fix(IS_STRUCTURE); -NODES[2530].Fix(IS_STRUCTURE); -NODES[2533].Fix(IS_STRUCTURE); -NODES[2540].Fix(IS_STRUCTURE); -NODES[2543].Fix(IS_STRUCTURE); -NODES[2545].Fix(IS_STRUCTURE); -NODES[2549].Fix(IS_STRUCTURE); -NODES[2551].Fix(IS_STRUCTURE); -NODES[2552].Fix(IS_STRUCTURE); -NODES[2554].Fix(IS_STRUCTURE); -NODES[2559].Fix(IS_STRUCTURE); -NODES[2560].Fix(IS_STRUCTURE); -NODES[2571].Fix(IS_STRUCTURE); -NODES[2573].Fix(IS_STRUCTURE); -NODES[2574].Fix(IS_STRUCTURE); -NODES[2575].Fix(IS_STRUCTURE); -NODES[2576].Fix(IS_STRUCTURE); -NODES[2579].Fix(IS_STRUCTURE); -NODES[2580].Fix(IS_STRUCTURE); -NODES[2584].Fix(IS_STRUCTURE); -NODES[2585].Fix(IS_STRUCTURE); -NODES[2587].Fix(IS_STRUCTURE); -NODES[2589].Fix(IS_STRUCTURE); -NODES[2591].Fix(IS_STRUCTURE); -NODES[2596].Fix(IS_STRUCTURE); -NODES[2597].Fix(IS_STRUCTURE); -NODES[2599].Fix(IS_STRUCTURE); -NODES[2600].Fix(IS_STRUCTURE); -NODES[2603].Fix(IS_STRUCTURE); -NODES[2604].Fix(IS_STRUCTURE); -NODES[2608].Fix(IS_STRUCTURE); -NODES[2612].Fix(IS_STRUCTURE); -NODES[2617].Fix(IS_STRUCTURE); -NODES[2621].Fix(IS_STRUCTURE); -NODES[2622].Fix(IS_STRUCTURE); -NODES[2624].Fix(IS_STRUCTURE); -NODES[2625].Fix(IS_STRUCTURE); -NODES[2629].Fix(IS_STRUCTURE); -NODES[2631].Fix(IS_STRUCTURE); -NODES[2632].Fix(IS_STRUCTURE); -NODES[2633].Fix(IS_STRUCTURE); -NODES[2643].Fix(IS_STRUCTURE); -NODES[2645].Fix(IS_STRUCTURE); -NODES[2646].Fix(IS_STRUCTURE); -NODES[2656].Fix(IS_STRUCTURE); -NODES[2657].Fix(IS_STRUCTURE); -NODES[2658].Fix(IS_STRUCTURE); -NODES[2661].Fix(IS_STRUCTURE); -NODES[2663].Fix(IS_STRUCTURE); -NODES[2668].Fix(IS_STRUCTURE); -NODES[2669].Fix(IS_STRUCTURE); -NODES[2678].Fix(IS_STRUCTURE); -NODES[2679].Fix(IS_STRUCTURE); -NODES[2684].Fix(IS_STRUCTURE); -NODES[2685].Fix(IS_STRUCTURE); -NODES[2690].Fix(IS_STRUCTURE); -NODES[2691].Fix(IS_STRUCTURE); -NODES[2693].Fix(IS_STRUCTURE); -NODES[2698].Fix(IS_STRUCTURE); -NODES[2702].Fix(IS_STRUCTURE); -NODES[2707].Fix(IS_STRUCTURE); -NODES[2712].Fix(IS_STRUCTURE); -NODES[2726].Fix(IS_STRUCTURE); -NODES[2730].Fix(IS_STRUCTURE); -NODES[2731].Fix(IS_STRUCTURE); -NODES[2732].Fix(IS_STRUCTURE); -NODES[2737].Fix(IS_STRUCTURE); -NODES[2754].Fix(IS_STRUCTURE); -NODES[2755].Fix(IS_STRUCTURE); -NODES[2757].Fix(IS_STRUCTURE); -NODES[2758].Fix(IS_STRUCTURE); -NODES[2759].Fix(IS_STRUCTURE); -NODES[2764].Fix(IS_STRUCTURE); -NODES[2766].Fix(IS_STRUCTURE); -NODES[2769].Fix(IS_STRUCTURE); -NODES[2773].Fix(IS_STRUCTURE); -NODES[2780].Fix(IS_STRUCTURE); -NODES[2782].Fix(IS_STRUCTURE); -NODES[2785].Fix(IS_STRUCTURE); -NODES[2786].Fix(IS_STRUCTURE); -NODES[2787].Fix(IS_STRUCTURE); -NODES[2790].Fix(IS_STRUCTURE); -NODES[2791].Fix(IS_STRUCTURE); -NODES[2795].Fix(IS_STRUCTURE); -NODES[2796].Fix(IS_STRUCTURE); -NODES[2802].Fix(IS_STRUCTURE); -NODES[2807].Fix(IS_STRUCTURE); -NODES[2809].Fix(IS_STRUCTURE); -NODES[2810].Fix(IS_STRUCTURE); -NODES[2814].Fix(IS_STRUCTURE); -NODES[2815].Fix(IS_STRUCTURE); -NODES[2821].Fix(IS_STRUCTURE); -NODES[2822].Fix(IS_STRUCTURE); -NODES[2824].Fix(IS_STRUCTURE); -NODES[2829].Fix(IS_STRUCTURE); -NODES[2837].Fix(IS_STRUCTURE); -NODES[2839].Fix(IS_STRUCTURE); -NODES[2848].Fix(IS_STRUCTURE); -NODES[2850].Fix(IS_STRUCTURE); -NODES[2856].Fix(IS_STRUCTURE); -NODES[2857].Fix(IS_STRUCTURE); -NODES[2861].Fix(IS_STRUCTURE); -NODES[2862].Fix(IS_STRUCTURE); -NODES[2867].Fix(IS_STRUCTURE); -NODES[2873].Fix(IS_STRUCTURE); -NODES[2874].Fix(IS_STRUCTURE); -NODES[2877].Fix(IS_STRUCTURE); -NODES[2879].Fix(IS_STRUCTURE); -NODES[2887].Fix(IS_STRUCTURE); -NODES[2893].Fix(IS_STRUCTURE); -NODES[2894].Fix(IS_STRUCTURE); -NODES[2896].Fix(IS_STRUCTURE); -NODES[2897].Fix(IS_STRUCTURE); -NODES[2901].Fix(IS_STRUCTURE); -NODES[2903].Fix(IS_STRUCTURE); -NODES[2907].Fix(IS_STRUCTURE); -NODES[2908].Fix(IS_STRUCTURE); -NODES[2909].Fix(IS_STRUCTURE); -NODES[2915].Fix(IS_STRUCTURE); -NODES[2918].Fix(IS_STRUCTURE); -NODES[2921].Fix(IS_STRUCTURE); -NODES[2922].Fix(IS_STRUCTURE); -NODES[2923].Fix(IS_STRUCTURE); -NODES[2929].Fix(IS_STRUCTURE); -NODES[2933].Fix(IS_STRUCTURE); -NODES[2934].Fix(IS_STRUCTURE); -NODES[2937].Fix(IS_STRUCTURE); -NODES[2939].Fix(IS_STRUCTURE); -NODES[2942].Fix(IS_STRUCTURE); -NODES[2950].Fix(IS_STRUCTURE); -NODES[2951].Fix(IS_STRUCTURE); -NODES[2958].Fix(IS_STRUCTURE); -NODES[2966].Fix(IS_STRUCTURE); -NODES[2967].Fix(IS_STRUCTURE); -NODES[2968].Fix(IS_STRUCTURE); -NODES[2972].Fix(IS_STRUCTURE); -NODES[2975].Fix(IS_STRUCTURE); -NODES[2977].Fix(IS_STRUCTURE); -NODES[2982].Fix(IS_STRUCTURE); -NODES[2983].Fix(IS_STRUCTURE); -NODES[2990].Fix(IS_STRUCTURE); -NODES[2991].Fix(IS_STRUCTURE); -NODES[2992].Fix(IS_STRUCTURE); -NODES[3001].Fix(IS_STRUCTURE); -NODES[3003].Fix(IS_STRUCTURE); -NODES[3004].Fix(IS_STRUCTURE); -NODES[3005].Fix(IS_STRUCTURE); -NODES[3006].Fix(IS_STRUCTURE); -NODES[3021].Fix(IS_STRUCTURE); -NODES[3028].Fix(IS_STRUCTURE); -NODES[3029].Fix(IS_STRUCTURE); -NODES[3030].Fix(IS_STRUCTURE); -NODES[3033].Fix(IS_STRUCTURE); -NODES[3034].Fix(IS_STRUCTURE); -NODES[3039].Fix(IS_STRUCTURE); -NODES[3045].Fix(IS_STRUCTURE); -NODES[3048].Fix(IS_STRUCTURE); -NODES[3051].Fix(IS_STRUCTURE); -NODES[3054].Fix(IS_STRUCTURE); -NODES[3055].Fix(IS_STRUCTURE); -NODES[3058].Fix(IS_STRUCTURE); -NODES[3059].Fix(IS_STRUCTURE); -NODES[3063].Fix(IS_STRUCTURE); -NODES[3079].Fix(IS_STRUCTURE); -NODES[3083].Fix(IS_STRUCTURE); -NODES[3085].Fix(IS_STRUCTURE); -NODES[3086].Fix(IS_STRUCTURE); -NODES[3091].Fix(IS_STRUCTURE); -NODES[3093].Fix(IS_STRUCTURE); -NODES[3097].Fix(IS_STRUCTURE); -NODES[3099].Fix(IS_STRUCTURE); -NODES[3100].Fix(IS_STRUCTURE); -NODES[3101].Fix(IS_STRUCTURE); -NODES[3105].Fix(IS_STRUCTURE); -NODES[3110].Fix(IS_STRUCTURE); -NODES[3119].Fix(IS_STRUCTURE); -NODES[3121].Fix(IS_STRUCTURE); -NODES[3131].Fix(IS_STRUCTURE); -NODES[3134].Fix(IS_STRUCTURE); -NODES[3153].Fix(IS_STRUCTURE); -NODES[3161].Fix(IS_STRUCTURE); -NODES[3165].Fix(IS_STRUCTURE); -NODES[3166].Fix(IS_STRUCTURE); -NODES[3167].Fix(IS_STRUCTURE); -NODES[3170].Fix(IS_STRUCTURE); -NODES[3171].Fix(IS_STRUCTURE); -NODES[3177].Fix(IS_STRUCTURE); -NODES[3194].Fix(IS_STRUCTURE); -NODES[3199].Fix(IS_STRUCTURE); -NODES[3217].Fix(IS_STRUCTURE); -NODES[3218].Fix(IS_STRUCTURE); -NODES[3220].Fix(IS_STRUCTURE); -NODES[3225].Fix(IS_STRUCTURE); -NODES[3228].Fix(IS_STRUCTURE); -NODES[3240].Fix(IS_STRUCTURE); -NODES[3241].Fix(IS_STRUCTURE); -NODES[3243].Fix(IS_STRUCTURE); -NODES[3251].Fix(IS_STRUCTURE); -NODES[3258].Fix(IS_STRUCTURE); -NODES[3264].Fix(IS_STRUCTURE); -NODES[3265].Fix(IS_STRUCTURE); -NODES[3268].Fix(IS_STRUCTURE); -NODES[3270].Fix(IS_STRUCTURE); -NODES[3272].Fix(IS_STRUCTURE); -NODES[3275].Fix(IS_STRUCTURE); -NODES[3276].Fix(IS_STRUCTURE); -NODES[3278].Fix(IS_STRUCTURE); -NODES[3279].Fix(IS_STRUCTURE); -NODES[3280].Fix(IS_STRUCTURE); -NODES[3282].Fix(IS_STRUCTURE); -NODES[3283].Fix(IS_STRUCTURE); -NODES[3287].Fix(IS_STRUCTURE); -NODES[3293].Fix(IS_STRUCTURE); -NODES[3294].Fix(IS_STRUCTURE); -NODES[3297].Fix(IS_STRUCTURE); -NODES[3301].Fix(IS_STRUCTURE); -NODES[3302].Fix(IS_STRUCTURE); -NODES[3303].Fix(IS_STRUCTURE); -NODES[3309].Fix(IS_STRUCTURE); -NODES[3311].Fix(IS_STRUCTURE); -NODES[3315].Fix(IS_STRUCTURE); -NODES[3322].Fix(IS_STRUCTURE); -NODES[3323].Fix(IS_STRUCTURE); -NODES[3324].Fix(IS_STRUCTURE); -NODES[3325].Fix(IS_STRUCTURE); -NODES[3341].Fix(IS_STRUCTURE); -NODES[3345].Fix(IS_STRUCTURE); -NODES[3346].Fix(IS_STRUCTURE); -NODES[3348].Fix(IS_STRUCTURE); -NODES[3350].Fix(IS_STRUCTURE); -NODES[3352].Fix(IS_STRUCTURE); -NODES[3354].Fix(IS_STRUCTURE); -NODES[3359].Fix(IS_STRUCTURE); -NODES[3366].Fix(IS_STRUCTURE); -NODES[3368].Fix(IS_STRUCTURE); -NODES[3372].Fix(IS_STRUCTURE); -NODES[3377].Fix(IS_STRUCTURE); -NODES[3380].Fix(IS_STRUCTURE); -NODES[3389].Fix(IS_STRUCTURE); -NODES[3390].Fix(IS_STRUCTURE); -NODES[3395].Fix(IS_STRUCTURE); -NODES[3399].Fix(IS_STRUCTURE); -NODES[3400].Fix(IS_STRUCTURE); -NODES[3405].Fix(IS_STRUCTURE); -NODES[3408].Fix(IS_STRUCTURE); -NODES[3412].Fix(IS_STRUCTURE); -NODES[3422].Fix(IS_STRUCTURE); -NODES[3436].Fix(IS_STRUCTURE); -NODES[3439].Fix(IS_STRUCTURE); -NODES[3449].Fix(IS_STRUCTURE); -NODES[3454].Fix(IS_STRUCTURE); -NODES[3455].Fix(IS_STRUCTURE); -NODES[3456].Fix(IS_STRUCTURE); -NODES[3461].Fix(IS_STRUCTURE); -NODES[3463].Fix(IS_STRUCTURE); -NODES[3465].Fix(IS_STRUCTURE); -NODES[3474].Fix(IS_STRUCTURE); -NODES[3475].Fix(IS_STRUCTURE); -NODES[3477].Fix(IS_STRUCTURE); -NODES[3481].Fix(IS_STRUCTURE); -NODES[3487].Fix(IS_STRUCTURE); -NODES[3493].Fix(IS_STRUCTURE); -NODES[3495].Fix(IS_STRUCTURE); -NODES[3496].Fix(IS_STRUCTURE); -NODES[3500].Fix(IS_STRUCTURE); -NODES[3521].Fix(IS_STRUCTURE); -NODES[3524].Fix(IS_STRUCTURE); -NODES[3529].Fix(IS_STRUCTURE); -NODES[3531].Fix(IS_STRUCTURE); -NODES[3532].Fix(IS_STRUCTURE); -NODES[3539].Fix(IS_STRUCTURE); -NODES[3541].Fix(IS_STRUCTURE); -NODES[3543].Fix(IS_STRUCTURE); -NODES[3558].Fix(IS_STRUCTURE); -NODES[3567].Fix(IS_STRUCTURE); -NODES[3571].Fix(IS_STRUCTURE); -NODES[3580].Fix(IS_STRUCTURE); -NODES[3585].Fix(IS_STRUCTURE); -NODES[3587].Fix(IS_STRUCTURE); -NODES[3615].Fix(IS_STRUCTURE); -NODES[3620].Fix(IS_STRUCTURE); -NODES[3621].Fix(IS_STRUCTURE); -NODES[3624].Fix(IS_STRUCTURE); -NODES[3626].Fix(IS_STRUCTURE); -NODES[3627].Fix(IS_STRUCTURE); -NODES[3628].Fix(IS_STRUCTURE); -NODES[3633].Fix(IS_STRUCTURE); -NODES[3645].Fix(IS_STRUCTURE); -NODES[3648].Fix(IS_STRUCTURE); -NODES[3650].Fix(IS_STRUCTURE); -NODES[3653].Fix(IS_STRUCTURE); -NODES[3657].Fix(IS_STRUCTURE); -NODES[3664].Fix(IS_STRUCTURE); -NODES[3674].Fix(IS_STRUCTURE); -NODES[3685].Fix(IS_STRUCTURE); -NODES[3689].Fix(IS_STRUCTURE); -NODES[3690].Fix(IS_STRUCTURE); -NODES[3693].Fix(IS_STRUCTURE); -NODES[3694].Fix(IS_STRUCTURE); -NODES[3695].Fix(IS_STRUCTURE); -NODES[3697].Fix(IS_STRUCTURE); -NODES[3701].Fix(IS_STRUCTURE); -NODES[3702].Fix(IS_STRUCTURE); -NODES[3703].Fix(IS_STRUCTURE); -NODES[3705].Fix(IS_STRUCTURE); -NODES[3706].Fix(IS_STRUCTURE); -NODES[3707].Fix(IS_STRUCTURE); -NODES[3709].Fix(IS_STRUCTURE); -NODES[3710].Fix(IS_STRUCTURE); -NODES[3711].Fix(IS_STRUCTURE); -NODES[3715].Fix(IS_STRUCTURE); -NODES[3718].Fix(IS_STRUCTURE); -NODES[3722].Fix(IS_STRUCTURE); -NODES[3724].Fix(IS_STRUCTURE); -NODES[3729].Fix(IS_STRUCTURE); -NODES[3732].Fix(IS_STRUCTURE); -NODES[3733].Fix(IS_STRUCTURE); -NODES[3735].Fix(IS_STRUCTURE); -NODES[3736].Fix(IS_STRUCTURE); -NODES[3742].Fix(IS_STRUCTURE); -NODES[3749].Fix(IS_STRUCTURE); -NODES[3750].Fix(IS_STRUCTURE); -NODES[3753].Fix(IS_STRUCTURE); -NODES[3757].Fix(IS_STRUCTURE); -NODES[3758].Fix(IS_STRUCTURE); -NODES[3759].Fix(IS_STRUCTURE); -NODES[3761].Fix(IS_STRUCTURE); -NODES[3775].Fix(IS_STRUCTURE); -NODES[3790].Fix(IS_STRUCTURE); -NODES[3791].Fix(IS_STRUCTURE); -NODES[3792].Fix(IS_STRUCTURE); -NODES[3803].Fix(IS_STRUCTURE); -NODES[3804].Fix(IS_STRUCTURE); -NODES[3806].Fix(IS_STRUCTURE); -NODES[3821].Fix(IS_STRUCTURE); -NODES[3824].Fix(IS_STRUCTURE); -NODES[3830].Fix(IS_STRUCTURE); -NODES[3833].Fix(IS_STRUCTURE); -NODES[3836].Fix(IS_STRUCTURE); -NODES[3841].Fix(IS_STRUCTURE); -NODES[3849].Fix(IS_STRUCTURE); -NODES[3850].Fix(IS_STRUCTURE); -NODES[3858].Fix(IS_STRUCTURE); -NODES[3859].Fix(IS_STRUCTURE); -NODES[3865].Fix(IS_STRUCTURE); -NODES[3870].Fix(IS_STRUCTURE); -NODES[3872].Fix(IS_STRUCTURE); -NODES[3887].Fix(IS_STRUCTURE); -NODES[3889].Fix(IS_STRUCTURE); -NODES[3891].Fix(IS_STRUCTURE); -NODES[3896].Fix(IS_STRUCTURE); -NODES[3901].Fix(IS_STRUCTURE); -NODES[3915].Fix(IS_STRUCTURE); -NODES[3920].Fix(IS_STRUCTURE); -NODES[3921].Fix(IS_STRUCTURE); -NODES[3923].Fix(IS_STRUCTURE); -NODES[3929].Fix(IS_STRUCTURE); -NODES[3931].Fix(IS_STRUCTURE); -NODES[3937].Fix(IS_STRUCTURE); -NODES[3938].Fix(IS_STRUCTURE); -NODES[3953].Fix(IS_STRUCTURE); -NODES[3963].Fix(IS_STRUCTURE); -NODES[3968].Fix(IS_STRUCTURE); -NODES[3969].Fix(IS_STRUCTURE); -NODES[3972].Fix(IS_STRUCTURE); -NODES[3975].Fix(IS_STRUCTURE); -NODES[3981].Fix(IS_STRUCTURE); -NODES[3987].Fix(IS_STRUCTURE); -NODES[3997].Fix(IS_STRUCTURE); -NODES[3998].Fix(IS_STRUCTURE); -NODES[4002].Fix(IS_STRUCTURE); -NODES[4006].Fix(IS_STRUCTURE); -NODES[4018].Fix(IS_STRUCTURE); -NODES[4020].Fix(IS_STRUCTURE); -NODES[4021].Fix(IS_STRUCTURE); -NODES[4024].Fix(IS_STRUCTURE); -NODES[4038].Fix(IS_STRUCTURE); -NODES[4042].Fix(IS_STRUCTURE); -NODES[4046].Fix(IS_STRUCTURE); -NODES[4050].Fix(IS_STRUCTURE); -NODES[4065].Fix(IS_STRUCTURE); -NODES[4073].Fix(IS_STRUCTURE); -NODES[4076].Fix(IS_STRUCTURE); -NODES[4079].Fix(IS_STRUCTURE); -NODES[4082].Fix(IS_STRUCTURE); -NODES[4085].Fix(IS_STRUCTURE); -NODES[4093].Fix(IS_STRUCTURE); -NODES[4095].Fix(IS_STRUCTURE); -NODES[4096].Fix(IS_STRUCTURE); -NODES[4099].Fix(IS_STRUCTURE); -NODES[4108].Fix(IS_STRUCTURE); -NODES[4114].Fix(IS_STRUCTURE); -NODES[4115].Fix(IS_STRUCTURE); -NODES[4123].Fix(IS_STRUCTURE); -NODES[4124].Fix(IS_STRUCTURE); -NODES[4138].Fix(IS_STRUCTURE); -NODES[4148].Fix(IS_STRUCTURE); -NODES[4149].Fix(IS_STRUCTURE); -NODES[4151].Fix(IS_STRUCTURE); -NODES[4152].Fix(IS_STRUCTURE); -NODES[4157].Fix(IS_STRUCTURE); -NODES[4158].Fix(IS_STRUCTURE); -NODES[4161].Fix(IS_STRUCTURE); -NODES[4163].Fix(IS_STRUCTURE); -NODES[4167].Fix(IS_STRUCTURE); -NODES[4168].Fix(IS_STRUCTURE); -NODES[4172].Fix(IS_STRUCTURE); -NODES[4174].Fix(IS_STRUCTURE); -NODES[4178].Fix(IS_STRUCTURE); -NODES[4179].Fix(IS_STRUCTURE); -NODES[4187].Fix(IS_STRUCTURE); -NODES[4188].Fix(IS_STRUCTURE); -NODES[4191].Fix(IS_STRUCTURE); -NODES[4192].Fix(IS_STRUCTURE); -NODES[4197].Fix(IS_STRUCTURE); -NODES[4200].Fix(IS_STRUCTURE); -NODES[4201].Fix(IS_STRUCTURE); -NODES[4211].Fix(IS_STRUCTURE); -NODES[4227].Fix(IS_STRUCTURE); -NODES[4235].Fix(IS_STRUCTURE); -NODES[4236].Fix(IS_STRUCTURE); -NODES[4245].Fix(IS_STRUCTURE); -NODES[4246].Fix(IS_STRUCTURE); -NODES[4247].Fix(IS_STRUCTURE); -NODES[4252].Fix(IS_STRUCTURE); -NODES[4256].Fix(IS_STRUCTURE); -NODES[4257].Fix(IS_STRUCTURE); -NODES[4270].Fix(IS_STRUCTURE); -NODES[4277].Fix(IS_STRUCTURE); -NODES[4283].Fix(IS_STRUCTURE); -NODES[4298].Fix(IS_STRUCTURE); -NODES[4299].Fix(IS_STRUCTURE); -NODES[4309].Fix(IS_STRUCTURE); -NODES[4310].Fix(IS_STRUCTURE); -NODES[4313].Fix(IS_STRUCTURE); -NODES[4316].Fix(IS_STRUCTURE); -NODES[4329].Fix(IS_STRUCTURE); -NODES[4332].Fix(IS_STRUCTURE); -NODES[4333].Fix(IS_STRUCTURE); -NODES[4336].Fix(IS_STRUCTURE); -NODES[4342].Fix(IS_STRUCTURE); -NODES[4346].Fix(IS_STRUCTURE); -NODES[4347].Fix(IS_STRUCTURE); -NODES[4358].Fix(IS_STRUCTURE); -NODES[4366].Fix(IS_STRUCTURE); -NODES[4373].Fix(IS_STRUCTURE); -NODES[4374].Fix(IS_STRUCTURE); -NODES[4382].Fix(IS_STRUCTURE); -NODES[4394].Fix(IS_STRUCTURE); -NODES[4396].Fix(IS_STRUCTURE); -NODES[4397].Fix(IS_STRUCTURE); -NODES[4398].Fix(IS_STRUCTURE); -NODES[4400].Fix(IS_STRUCTURE); -NODES[4401].Fix(IS_STRUCTURE); -NODES[4402].Fix(IS_STRUCTURE); -NODES[4412].Fix(IS_STRUCTURE); -NODES[4435].Fix(IS_STRUCTURE); -NODES[4438].Fix(IS_STRUCTURE); -NODES[4455].Fix(IS_STRUCTURE); -NODES[4456].Fix(IS_STRUCTURE); -NODES[4457].Fix(IS_STRUCTURE); -NODES[4458].Fix(IS_STRUCTURE); -NODES[4470].Fix(IS_STRUCTURE); -NODES[4484].Fix(IS_STRUCTURE); -NODES[4498].Fix(IS_STRUCTURE); -NODES[4505].Fix(IS_STRUCTURE); -NODES[4513].Fix(IS_STRUCTURE); -NODES[4515].Fix(IS_STRUCTURE); -NODES[4530].Fix(IS_STRUCTURE); -NODES[4535].Fix(IS_STRUCTURE); -NODES[4547].Fix(IS_STRUCTURE); -NODES[4549].Fix(IS_STRUCTURE); -NODES[4551].Fix(IS_STRUCTURE); -NODES[4553].Fix(IS_STRUCTURE); -NODES[4554].Fix(IS_STRUCTURE); -NODES[4563].Fix(IS_STRUCTURE); -NODES[4575].Fix(IS_STRUCTURE); -NODES[4576].Fix(IS_STRUCTURE); -NODES[4581].Fix(IS_STRUCTURE); -NODES[4582].Fix(IS_STRUCTURE); -NODES[4586].Fix(IS_STRUCTURE); -NODES[4588].Fix(IS_STRUCTURE); -NODES[4594].Fix(IS_STRUCTURE); -NODES[4598].Fix(IS_STRUCTURE); -NODES[4599].Fix(IS_STRUCTURE); -NODES[4605].Fix(IS_STRUCTURE); -NODES[4607].Fix(IS_STRUCTURE); -NODES[4611].Fix(IS_STRUCTURE); -NODES[4616].Fix(IS_STRUCTURE); -NODES[4627].Fix(IS_STRUCTURE); -NODES[4632].Fix(IS_STRUCTURE); -NODES[4642].Fix(IS_STRUCTURE); -NODES[4647].Fix(IS_STRUCTURE); -NODES[4648].Fix(IS_STRUCTURE); -NODES[4652].Fix(IS_STRUCTURE); -NODES[4665].Fix(IS_STRUCTURE); -NODES[4670].Fix(IS_STRUCTURE); -NODES[4671].Fix(IS_STRUCTURE); -NODES[4674].Fix(IS_STRUCTURE); -NODES[4675].Fix(IS_STRUCTURE); -NODES[4678].Fix(IS_STRUCTURE); -NODES[4686].Fix(IS_STRUCTURE); -NODES[4687].Fix(IS_STRUCTURE); -NODES[4696].Fix(IS_STRUCTURE); -NODES[4697].Fix(IS_STRUCTURE); -NODES[4702].Fix(IS_STRUCTURE); -NODES[4703].Fix(IS_STRUCTURE); -NODES[4704].Fix(IS_STRUCTURE); -NODES[4706].Fix(IS_STRUCTURE); -NODES[4707].Fix(IS_STRUCTURE); -NODES[4716].Fix(IS_STRUCTURE); -NODES[4728].Fix(IS_STRUCTURE); -NODES[4729].Fix(IS_STRUCTURE); -NODES[4732].Fix(IS_STRUCTURE); -NODES[4735].Fix(IS_STRUCTURE); -NODES[4736].Fix(IS_STRUCTURE); -NODES[4748].Fix(IS_STRUCTURE); -NODES[4749].Fix(IS_STRUCTURE); -NODES[4760].Fix(IS_STRUCTURE); -NODES[4764].Fix(IS_STRUCTURE); -NODES[4770].Fix(IS_STRUCTURE); -NODES[4773].Fix(IS_STRUCTURE); -NODES[4781].Fix(IS_STRUCTURE); -NODES[4785].Fix(IS_STRUCTURE); -NODES[4786].Fix(IS_STRUCTURE); -NODES[4789].Fix(IS_STRUCTURE); -NODES[4790].Fix(IS_STRUCTURE); -NODES[4823].Fix(IS_STRUCTURE); -NODES[4824].Fix(IS_STRUCTURE); -NODES[4836].Fix(IS_STRUCTURE); -NODES[4847].Fix(IS_STRUCTURE); -NODES[4848].Fix(IS_STRUCTURE); -NODES[4856].Fix(IS_STRUCTURE); -NODES[4865].Fix(IS_STRUCTURE); -NODES[4866].Fix(IS_STRUCTURE); -NODES[4868].Fix(IS_STRUCTURE); -NODES[4869].Fix(IS_STRUCTURE); -NODES[4877].Fix(IS_STRUCTURE); -NODES[4886].Fix(IS_STRUCTURE); -NODES[4895].Fix(IS_STRUCTURE); -NODES[4904].Fix(IS_STRUCTURE); -NODES[4908].Fix(IS_STRUCTURE); -NODES[4917].Fix(IS_STRUCTURE); -NODES[4925].Fix(IS_STRUCTURE); -NODES[4931].Fix(IS_STRUCTURE); -NODES[4932].Fix(IS_STRUCTURE); -NODES[4945].Fix(IS_STRUCTURE); -NODES[4960].Fix(IS_STRUCTURE); -NODES[4961].Fix(IS_STRUCTURE); -NODES[4966].Fix(IS_STRUCTURE); -NODES[4967].Fix(IS_STRUCTURE); -NODES[4970].Fix(IS_STRUCTURE); -NODES[4981].Fix(IS_STRUCTURE); -NODES[4982].Fix(IS_STRUCTURE); -NODES[4984].Fix(IS_STRUCTURE); -NODES[4988].Fix(IS_STRUCTURE); -NODES[4995].Fix(IS_STRUCTURE); -NODES[5000].Fix(IS_STRUCTURE); -NODES[5001].Fix(IS_STRUCTURE); -NODES[5011].Fix(IS_STRUCTURE); -NODES[5012].Fix(IS_STRUCTURE); -NODES[5024].Fix(IS_STRUCTURE); -NODES[5027].Fix(IS_STRUCTURE); -NODES[5029].Fix(IS_STRUCTURE); -NODES[5034].Fix(IS_STRUCTURE); -NODES[5041].Fix(IS_STRUCTURE); -NODES[5042].Fix(IS_STRUCTURE); -NODES[5066].Fix(IS_STRUCTURE); -NODES[5067].Fix(IS_STRUCTURE); -NODES[5071].Fix(IS_STRUCTURE); -NODES[5080].Fix(IS_STRUCTURE); -NODES[5083].Fix(IS_STRUCTURE); -NODES[5085].Fix(IS_STRUCTURE); -NODES[5101].Fix(IS_STRUCTURE); -NODES[5102].Fix(IS_STRUCTURE); -NODES[5104].Fix(IS_STRUCTURE); -NODES[5117].Fix(IS_STRUCTURE); -NODES[5134].Fix(IS_STRUCTURE); -NODES[5141].Fix(IS_STRUCTURE); -NODES[5142].Fix(IS_STRUCTURE); -NODES[5147].Fix(IS_STRUCTURE); -NODES[5154].Fix(IS_STRUCTURE); -NODES[5160].Fix(IS_STRUCTURE); -NODES[5161].Fix(IS_STRUCTURE); -NODES[5163].Fix(IS_STRUCTURE); -NODES[5177].Fix(IS_STRUCTURE); -NODES[5180].Fix(IS_STRUCTURE); -NODES[5181].Fix(IS_STRUCTURE); -NODES[5185].Fix(IS_STRUCTURE); -NODES[5198].Fix(IS_STRUCTURE); -NODES[5199].Fix(IS_STRUCTURE); -NODES[5221].Fix(IS_STRUCTURE); -NODES[5222].Fix(IS_STRUCTURE); -NODES[5230].Fix(IS_STRUCTURE); -NODES[5233].Fix(IS_STRUCTURE); -NODES[5246].Fix(IS_STRUCTURE); -NODES[5247].Fix(IS_STRUCTURE); -NODES[5253].Fix(IS_STRUCTURE); -NODES[5254].Fix(IS_STRUCTURE); -NODES[5257].Fix(IS_STRUCTURE); -NODES[5259].Fix(IS_STRUCTURE); -NODES[5260].Fix(IS_STRUCTURE); -NODES[5262].Fix(IS_STRUCTURE); -NODES[5263].Fix(IS_STRUCTURE); -NODES[5271].Fix(IS_STRUCTURE); -NODES[5275].Fix(IS_STRUCTURE); -NODES[5281].Fix(IS_STRUCTURE); -NODES[5289].Fix(IS_STRUCTURE); -NODES[5290].Fix(IS_STRUCTURE); -NODES[5291].Fix(IS_STRUCTURE); -NODES[5308].Fix(IS_STRUCTURE); -NODES[5325].Fix(IS_STRUCTURE); -NODES[5333].Fix(IS_STRUCTURE); -NODES[5334].Fix(IS_STRUCTURE); -NODES[5336].Fix(IS_STRUCTURE); -NODES[5337].Fix(IS_STRUCTURE); -NODES[5341].Fix(IS_STRUCTURE); -NODES[5343].Fix(IS_STRUCTURE); -NODES[5344].Fix(IS_STRUCTURE); -NODES[5357].Fix(IS_STRUCTURE); -NODES[5362].Fix(IS_STRUCTURE); -NODES[5375].Fix(IS_STRUCTURE); -NODES[5376].Fix(IS_STRUCTURE); -NODES[5389].Fix(IS_STRUCTURE); -NODES[5404].Fix(IS_STRUCTURE); -NODES[5405].Fix(IS_STRUCTURE); -NODES[5407].Fix(IS_STRUCTURE); -NODES[5425].Fix(IS_STRUCTURE); -NODES[5427].Fix(IS_STRUCTURE); -NODES[5435].Fix(IS_STRUCTURE); -NODES[5440].Fix(IS_STRUCTURE); -NODES[5445].Fix(IS_STRUCTURE); -NODES[5446].Fix(IS_STRUCTURE); -NODES[5480].Fix(IS_STRUCTURE); -NODES[5487].Fix(IS_STRUCTURE); -NODES[5491].Fix(IS_STRUCTURE); -NODES[5492].Fix(IS_STRUCTURE); -NODES[5496].Fix(IS_STRUCTURE); -NODES[5497].Fix(IS_STRUCTURE); -NODES[5499].Fix(IS_STRUCTURE); -NODES[5500].Fix(IS_STRUCTURE); -NODES[5501].Fix(IS_STRUCTURE); -NODES[5502].Fix(IS_STRUCTURE); -NODES[5503].Fix(IS_STRUCTURE); -NODES[5505].Fix(IS_STRUCTURE); -NODES[5510].Fix(IS_STRUCTURE); -NODES[5519].Fix(IS_STRUCTURE); -NODES[5528].Fix(IS_STRUCTURE); -NODES[5533].Fix(IS_STRUCTURE); -NODES[5534].Fix(IS_STRUCTURE); -NODES[5540].Fix(IS_STRUCTURE); -NODES[5548].Fix(IS_STRUCTURE); -NODES[5550].Fix(IS_STRUCTURE); -NODES[5551].Fix(IS_STRUCTURE); -NODES[5563].Fix(IS_STRUCTURE); -NODES[5568].Fix(IS_STRUCTURE); -NODES[5575].Fix(IS_STRUCTURE); -NODES[5579].Fix(IS_STRUCTURE); -NODES[5580].Fix(IS_STRUCTURE); -NODES[5587].Fix(IS_STRUCTURE); -NODES[5596].Fix(IS_STRUCTURE); -NODES[5597].Fix(IS_STRUCTURE); -NODES[5598].Fix(IS_STRUCTURE); -NODES[5618].Fix(IS_STRUCTURE); -NODES[5619].Fix(IS_STRUCTURE); -NODES[5620].Fix(IS_STRUCTURE); -NODES[5630].Fix(IS_STRUCTURE); -NODES[5638].Fix(IS_STRUCTURE); -NODES[5646].Fix(IS_STRUCTURE); -NODES[5647].Fix(IS_STRUCTURE); -NODES[5662].Fix(IS_STRUCTURE); -NODES[5678].Fix(IS_STRUCTURE); -NODES[5692].Fix(IS_STRUCTURE); -NODES[5693].Fix(IS_STRUCTURE); -NODES[5698].Fix(IS_STRUCTURE); -NODES[5705].Fix(IS_STRUCTURE); -NODES[5721].Fix(IS_STRUCTURE); -NODES[5722].Fix(IS_STRUCTURE); -NODES[5734].Fix(IS_STRUCTURE); -NODES[5735].Fix(IS_STRUCTURE); -NODES[5736].Fix(IS_STRUCTURE); -NODES[5746].Fix(IS_STRUCTURE); -NODES[5760].Fix(IS_STRUCTURE); -NODES[5768].Fix(IS_STRUCTURE); -NODES[5774].Fix(IS_STRUCTURE); -NODES[5782].Fix(IS_STRUCTURE); -NODES[5792].Fix(IS_STRUCTURE); -NODES[5799].Fix(IS_STRUCTURE); -NODES[5815].Fix(IS_STRUCTURE); -NODES[5820].Fix(IS_STRUCTURE); -NODES[5832].Fix(IS_STRUCTURE); -NODES[5836].Fix(IS_STRUCTURE); -NODES[5837].Fix(IS_STRUCTURE); -NODES[5850].Fix(IS_STRUCTURE); -NODES[5859].Fix(IS_STRUCTURE); -NODES[5860].Fix(IS_STRUCTURE); -NODES[5862].Fix(IS_STRUCTURE); -NODES[5867].Fix(IS_STRUCTURE); -NODES[5868].Fix(IS_STRUCTURE); -NODES[5876].Fix(IS_STRUCTURE); -NODES[5877].Fix(IS_STRUCTURE); -NODES[5899].Fix(IS_STRUCTURE); -NODES[5900].Fix(IS_STRUCTURE); -NODES[5901].Fix(IS_STRUCTURE); -NODES[5903].Fix(IS_STRUCTURE); -NODES[5904].Fix(IS_STRUCTURE); -NODES[5906].Fix(IS_STRUCTURE); -NODES[5920].Fix(IS_STRUCTURE); -NODES[5925].Fix(IS_STRUCTURE); -NODES[5931].Fix(IS_STRUCTURE); -NODES[5938].Fix(IS_STRUCTURE); -NODES[5939].Fix(IS_STRUCTURE); -NODES[5946].Fix(IS_STRUCTURE); -NODES[5960].Fix(IS_STRUCTURE); -NODES[5961].Fix(IS_STRUCTURE); -NODES[5962].Fix(IS_STRUCTURE); -NODES[5964].Fix(IS_STRUCTURE); -NODES[5972].Fix(IS_STRUCTURE); -NODES[5987].Fix(IS_STRUCTURE); -NODES[5988].Fix(IS_STRUCTURE); -NODES[6016].Fix(IS_STRUCTURE); -NODES[6025].Fix(IS_STRUCTURE); -NODES[6026].Fix(IS_STRUCTURE); -NODES[6033].Fix(IS_STRUCTURE); -NODES[6036].Fix(IS_STRUCTURE); -NODES[6041].Fix(IS_STRUCTURE); -NODES[6045].Fix(IS_STRUCTURE); -NODES[6054].Fix(IS_STRUCTURE); -NODES[6056].Fix(IS_STRUCTURE); -NODES[6057].Fix(IS_STRUCTURE); -NODES[6070].Fix(IS_STRUCTURE); -NODES[6071].Fix(IS_STRUCTURE); -NODES[6074].Fix(IS_STRUCTURE); -NODES[6077].Fix(IS_STRUCTURE); -NODES[6085].Fix(IS_STRUCTURE); -NODES[6089].Fix(IS_STRUCTURE); -NODES[6095].Fix(IS_STRUCTURE); -NODES[6096].Fix(IS_STRUCTURE); -NODES[6107].Fix(IS_STRUCTURE); -NODES[6108].Fix(IS_STRUCTURE); -NODES[6122].Fix(IS_STRUCTURE); -NODES[6124].Fix(IS_STRUCTURE); -NODES[6128].Fix(IS_STRUCTURE); -NODES[6129].Fix(IS_STRUCTURE); -NODES[6135].Fix(IS_STRUCTURE); -NODES[6136].Fix(IS_STRUCTURE); -NODES[6145].Fix(IS_STRUCTURE); -NODES[6154].Fix(IS_STRUCTURE); -NODES[6155].Fix(IS_STRUCTURE); -NODES[6175].Fix(IS_STRUCTURE); -NODES[6176].Fix(IS_STRUCTURE); -NODES[6195].Fix(IS_STRUCTURE); -NODES[6205].Fix(IS_STRUCTURE); -NODES[6209].Fix(IS_STRUCTURE); -NODES[6241].Fix(IS_STRUCTURE); -NODES[6242].Fix(IS_STRUCTURE); -NODES[6246].Fix(IS_STRUCTURE); -NODES[6252].Fix(IS_STRUCTURE); -NODES[6267].Fix(IS_STRUCTURE); -NODES[6275].Fix(IS_STRUCTURE); -NODES[6276].Fix(IS_STRUCTURE); -NODES[6279].Fix(IS_STRUCTURE); -NODES[6280].Fix(IS_STRUCTURE); -NODES[6288].Fix(IS_STRUCTURE); -NODES[6289].Fix(IS_STRUCTURE); -NODES[6290].Fix(IS_STRUCTURE); -NODES[6291].Fix(IS_STRUCTURE); -NODES[6293].Fix(IS_STRUCTURE); -NODES[6309].Fix(IS_STRUCTURE); -NODES[6310].Fix(IS_STRUCTURE); -NODES[6322].Fix(IS_STRUCTURE); -NODES[6323].Fix(IS_STRUCTURE); -NODES[6324].Fix(IS_STRUCTURE); -NODES[6325].Fix(IS_STRUCTURE); -NODES[6326].Fix(IS_STRUCTURE); -NODES[6327].Fix(IS_STRUCTURE); -NODES[6328].Fix(IS_STRUCTURE); -NODES[6343].Fix(IS_STRUCTURE); -NODES[6344].Fix(IS_STRUCTURE); -NODES[6356].Fix(IS_STRUCTURE); -NODES[6357].Fix(IS_STRUCTURE); -NODES[6358].Fix(IS_STRUCTURE); -NODES[6359].Fix(IS_STRUCTURE); -NODES[6377].Fix(IS_STRUCTURE); -NODES[6378].Fix(IS_STRUCTURE); -NODES[6379].Fix(IS_STRUCTURE); -NODES[6380].Fix(IS_STRUCTURE); -NODES[6381].Fix(IS_STRUCTURE); -NODES[6382].Fix(IS_STRUCTURE); -NODES[6384].Fix(IS_STRUCTURE); -NODES[6385].Fix(IS_STRUCTURE); -NODES[6392].Fix(IS_STRUCTURE); -NODES[6398].Fix(IS_STRUCTURE); -NODES[6400].Fix(IS_STRUCTURE); -NODES[6408].Fix(IS_STRUCTURE); -NODES[6409].Fix(IS_STRUCTURE); -NODES[6410].Fix(IS_STRUCTURE); -NODES[6420].Fix(IS_STRUCTURE); -NODES[6422].Fix(IS_STRUCTURE); -NODES[6423].Fix(IS_STRUCTURE); -NODES[6424].Fix(IS_STRUCTURE); -NODES[6425].Fix(IS_STRUCTURE); -NODES[6426].Fix(IS_STRUCTURE); -NODES[6434].Fix(IS_STRUCTURE); -NODES[6435].Fix(IS_STRUCTURE); -NODES[6436].Fix(IS_STRUCTURE); -NODES[6439].Fix(IS_STRUCTURE); -NODES[6440].Fix(IS_STRUCTURE); -NODES[6451].Fix(IS_STRUCTURE); -NODES[6452].Fix(IS_STRUCTURE); -NODES[6453].Fix(IS_STRUCTURE); -NODES[6454].Fix(IS_STRUCTURE); -NODES[6455].Fix(IS_STRUCTURE); -NODES[6469].Fix(IS_STRUCTURE); -NODES[6470].Fix(IS_STRUCTURE); -NODES[6473].Fix(IS_STRUCTURE); -NODES[6474].Fix(IS_STRUCTURE); -NODES[6478].Fix(IS_STRUCTURE); -NODES[6482].Fix(IS_STRUCTURE); -NODES[6484].Fix(IS_STRUCTURE); -NODES[6485].Fix(IS_STRUCTURE); -NODES[6486].Fix(IS_STRUCTURE); -NODES[6487].Fix(IS_STRUCTURE); -NODES[6499].Fix(IS_STRUCTURE); -NODES[6502].Fix(IS_STRUCTURE); -NODES[6506].Fix(IS_STRUCTURE); -NODES[6507].Fix(IS_STRUCTURE); -NODES[6508].Fix(IS_STRUCTURE); -NODES[6511].Fix(IS_STRUCTURE); -NODES[6529].Fix(IS_STRUCTURE); -NODES[6544].Fix(IS_STRUCTURE); -NODES[6545].Fix(IS_STRUCTURE); -NODES[6546].Fix(IS_STRUCTURE); -NODES[6547].Fix(IS_STRUCTURE); -NODES[6548].Fix(IS_STRUCTURE); -NODES[6549].Fix(IS_STRUCTURE); -NODES[6550].Fix(IS_STRUCTURE); -NODES[6561].Fix(IS_STRUCTURE); -NODES[6569].Fix(IS_STRUCTURE); -NODES[6570].Fix(IS_STRUCTURE); -NODES[6573].Fix(IS_STRUCTURE); -NODES[6577].Fix(IS_STRUCTURE); -NODES[6578].Fix(IS_STRUCTURE); -NODES[6579].Fix(IS_STRUCTURE); -NODES[6582].Fix(IS_STRUCTURE); -NODES[6593].Fix(IS_STRUCTURE); -NODES[6594].Fix(IS_STRUCTURE); -NODES[6595].Fix(IS_STRUCTURE); -NODES[6596].Fix(IS_STRUCTURE); -NODES[6597].Fix(IS_STRUCTURE); -NODES[6598].Fix(IS_STRUCTURE); -NODES[6603].Fix(IS_STRUCTURE); -NODES[6607].Fix(IS_STRUCTURE); -NODES[6609].Fix(IS_STRUCTURE); -NODES[6610].Fix(IS_STRUCTURE); -NODES[6620].Fix(IS_STRUCTURE); -NODES[6621].Fix(IS_STRUCTURE); -NODES[6622].Fix(IS_STRUCTURE); -NODES[6623].Fix(IS_STRUCTURE); -NODES[6632].Fix(IS_STRUCTURE); -NODES[6635].Fix(IS_STRUCTURE); -NODES[6640].Fix(IS_STRUCTURE); -NODES[6648].Fix(IS_STRUCTURE); -NODES[6649].Fix(IS_STRUCTURE); -NODES[6651].Fix(IS_STRUCTURE); -NODES[6658].Fix(IS_STRUCTURE); -NODES[6663].Fix(IS_STRUCTURE); -NODES[6665].Fix(IS_STRUCTURE); -NODES[6666].Fix(IS_STRUCTURE); -NODES[6673].Fix(IS_STRUCTURE); -NODES[6674].Fix(IS_STRUCTURE); -NODES[6681].Fix(IS_STRUCTURE); -NODES[6683].Fix(IS_STRUCTURE); -NODES[6684].Fix(IS_STRUCTURE); -NODES[6685].Fix(IS_STRUCTURE); -NODES[6686].Fix(IS_STRUCTURE); -NODES[6687].Fix(IS_STRUCTURE); -NODES[6695].Fix(IS_STRUCTURE); -NODES[6699].Fix(IS_STRUCTURE); -NODES[6700].Fix(IS_STRUCTURE); -NODES[6701].Fix(IS_STRUCTURE); -NODES[6702].Fix(IS_STRUCTURE); -NODES[6703].Fix(IS_STRUCTURE); -NODES[6704].Fix(IS_STRUCTURE); -NODES[6705].Fix(IS_STRUCTURE); -NODES[6712].Fix(IS_STRUCTURE); -NODES[6716].Fix(IS_STRUCTURE); -NODES[6717].Fix(IS_STRUCTURE); -NODES[6727].Fix(IS_STRUCTURE); -NODES[6731].Fix(IS_STRUCTURE); -NODES[6732].Fix(IS_STRUCTURE); -NODES[6733].Fix(IS_STRUCTURE); -NODES[6734].Fix(IS_STRUCTURE); -NODES[6735].Fix(IS_STRUCTURE); -NODES[6743].Fix(IS_STRUCTURE); -NODES[6752].Fix(IS_STRUCTURE); -NODES[6753].Fix(IS_STRUCTURE); -NODES[6760].Fix(IS_STRUCTURE); -NODES[6769].Fix(IS_STRUCTURE); -NODES[6774].Fix(IS_STRUCTURE); -NODES[6775].Fix(IS_STRUCTURE); -NODES[6782].Fix(IS_STRUCTURE); -NODES[6783].Fix(IS_STRUCTURE); -NODES[6784].Fix(IS_STRUCTURE); -NODES[6785].Fix(IS_STRUCTURE); -NODES[6786].Fix(IS_STRUCTURE); -NODES[6787].Fix(IS_STRUCTURE); -NODES[6820].Fix(IS_STRUCTURE); -NODES[6827].Fix(IS_STRUCTURE); -NODES[6831].Fix(IS_STRUCTURE); -NODES[6833].Fix(IS_STRUCTURE); -NODES[6834].Fix(IS_STRUCTURE); -NODES[6837].Fix(IS_STRUCTURE); -NODES[6840].Fix(IS_STRUCTURE); -NODES[6843].Fix(IS_STRUCTURE); -NODES[6844].Fix(IS_STRUCTURE); -NODES[6845].Fix(IS_STRUCTURE); -NODES[6846].Fix(IS_STRUCTURE); -NODES[6847].Fix(IS_STRUCTURE); -NODES[6848].Fix(IS_STRUCTURE); -NODES[6849].Fix(IS_STRUCTURE); -NODES[6850].Fix(IS_STRUCTURE); -NODES[6851].Fix(IS_STRUCTURE); -NODES[6852].Fix(IS_STRUCTURE); -NODES[6857].Fix(IS_STRUCTURE); -NODES[6858].Fix(IS_STRUCTURE); -NODES[6865].Fix(IS_STRUCTURE); -NODES[6866].Fix(IS_STRUCTURE); -NODES[6870].Fix(IS_STRUCTURE); -NODES[6876].Fix(IS_STRUCTURE); -NODES[6877].Fix(IS_STRUCTURE); -NODES[6880].Fix(IS_STRUCTURE); -NODES[6881].Fix(IS_STRUCTURE); -NODES[6882].Fix(IS_STRUCTURE); -NODES[6883].Fix(IS_STRUCTURE); -NODES[6884].Fix(IS_STRUCTURE); -NODES[6903].Fix(IS_STRUCTURE); -NODES[6907].Fix(IS_STRUCTURE); -NODES[6913].Fix(IS_STRUCTURE); -NODES[6922].Fix(IS_STRUCTURE); -NODES[6929].Fix(IS_STRUCTURE); -NODES[6930].Fix(IS_STRUCTURE); -NODES[6931].Fix(IS_STRUCTURE); -NODES[6932].Fix(IS_STRUCTURE); -NODES[6948].Fix(IS_STRUCTURE); -NODES[6961].Fix(IS_STRUCTURE); -NODES[6962].Fix(IS_STRUCTURE); -NODES[6963].Fix(IS_STRUCTURE); -NODES[6972].Fix(IS_STRUCTURE); -NODES[6973].Fix(IS_STRUCTURE); -NODES[6974].Fix(IS_STRUCTURE); -NODES[6975].Fix(IS_STRUCTURE); -NODES[6983].Fix(IS_STRUCTURE); -NODES[6990].Fix(IS_STRUCTURE); -NODES[6996].Fix(IS_STRUCTURE); -NODES[7001].Fix(IS_STRUCTURE); -NODES[7002].Fix(IS_STRUCTURE); -NODES[7003].Fix(IS_STRUCTURE); -NODES[7004].Fix(IS_STRUCTURE); -NODES[7006].Fix(IS_STRUCTURE); -NODES[7008].Fix(IS_STRUCTURE); -NODES[7009].Fix(IS_STRUCTURE); -NODES[7012].Fix(IS_STRUCTURE); -NODES[7017].Fix(IS_STRUCTURE); -NODES[7018].Fix(IS_STRUCTURE); -NODES[7019].Fix(IS_STRUCTURE); -NODES[7020].Fix(IS_STRUCTURE); -NODES[7021].Fix(IS_STRUCTURE); -NODES[7029].Fix(IS_STRUCTURE); -NODES[7033].Fix(IS_STRUCTURE); -NODES[7039].Fix(IS_STRUCTURE); -NODES[7044].Fix(IS_STRUCTURE); -NODES[7045].Fix(IS_STRUCTURE); -NODES[7046].Fix(IS_STRUCTURE); -NODES[7047].Fix(IS_STRUCTURE); -NODES[7048].Fix(IS_STRUCTURE); -NODES[7049].Fix(IS_STRUCTURE); -NODES[7060].Fix(IS_STRUCTURE); -NODES[7066].Fix(IS_STRUCTURE); -NODES[7070].Fix(IS_STRUCTURE); -NODES[7075].Fix(IS_STRUCTURE); -NODES[7080].Fix(IS_STRUCTURE); -NODES[7083].Fix(IS_STRUCTURE); -NODES[7084].Fix(IS_STRUCTURE); -NODES[7099].Fix(IS_STRUCTURE); -NODES[7100].Fix(IS_STRUCTURE); -NODES[7101].Fix(IS_STRUCTURE); -NODES[7102].Fix(IS_STRUCTURE); -NODES[7103].Fix(IS_STRUCTURE); -NODES[7108].Fix(IS_STRUCTURE); -NODES[7125].Fix(IS_STRUCTURE); -NODES[7131].Fix(IS_STRUCTURE); -NODES[7136].Fix(IS_STRUCTURE); -NODES[7137].Fix(IS_STRUCTURE); -NODES[7138].Fix(IS_STRUCTURE); -NODES[7144].Fix(IS_STRUCTURE); -NODES[7145].Fix(IS_STRUCTURE); -NODES[7160].Fix(IS_STRUCTURE); -NODES[7162].Fix(IS_STRUCTURE); -NODES[7168].Fix(IS_STRUCTURE); -NODES[7173].Fix(IS_STRUCTURE); -NODES[7174].Fix(IS_STRUCTURE); -NODES[7175].Fix(IS_STRUCTURE); -NODES[7176].Fix(IS_STRUCTURE); -NODES[7177].Fix(IS_STRUCTURE); -NODES[7179].Fix(IS_STRUCTURE); -NODES[7183].Fix(IS_STRUCTURE); -NODES[7186].Fix(IS_STRUCTURE); -NODES[7187].Fix(IS_STRUCTURE); -NODES[7203].Fix(IS_STRUCTURE); -NODES[7204].Fix(IS_STRUCTURE); -NODES[7205].Fix(IS_STRUCTURE); -NODES[7206].Fix(IS_STRUCTURE); -NODES[7207].Fix(IS_STRUCTURE); -NODES[7229].Fix(IS_STRUCTURE); -NODES[7232].Fix(IS_STRUCTURE); -NODES[7239].Fix(IS_STRUCTURE); -NODES[7245].Fix(IS_STRUCTURE); -NODES[7246].Fix(IS_STRUCTURE); -NODES[7247].Fix(IS_STRUCTURE); -NODES[7248].Fix(IS_STRUCTURE); -NODES[7251].Fix(IS_STRUCTURE); -NODES[7255].Fix(IS_STRUCTURE); -NODES[7256].Fix(IS_STRUCTURE); -NODES[7261].Fix(IS_STRUCTURE); -NODES[7276].Fix(IS_STRUCTURE); -NODES[7281].Fix(IS_STRUCTURE); -NODES[7282].Fix(IS_STRUCTURE); -NODES[7301].Fix(IS_STRUCTURE); -NODES[7321].Fix(IS_STRUCTURE); -NODES[7322].Fix(IS_STRUCTURE); -NODES[7323].Fix(IS_STRUCTURE); -NODES[7324].Fix(IS_STRUCTURE); -NODES[7325].Fix(IS_STRUCTURE); -NODES[7327].Fix(IS_STRUCTURE); -NODES[7331].Fix(IS_STRUCTURE); -NODES[7334].Fix(IS_STRUCTURE); -NODES[7335].Fix(IS_STRUCTURE); -NODES[7338].Fix(IS_STRUCTURE); -NODES[7345].Fix(IS_STRUCTURE); -NODES[7349].Fix(IS_STRUCTURE); -NODES[7350].Fix(IS_STRUCTURE); -NODES[7361].Fix(IS_STRUCTURE); -NODES[7366].Fix(IS_STRUCTURE); -NODES[7369].Fix(IS_STRUCTURE); -NODES[7370].Fix(IS_STRUCTURE); -NODES[7380].Fix(IS_STRUCTURE); -NODES[7383].Fix(IS_STRUCTURE); -NODES[7384].Fix(IS_STRUCTURE); -NODES[7386].Fix(IS_STRUCTURE); -NODES[7388].Fix(IS_STRUCTURE); -NODES[7389].Fix(IS_STRUCTURE); -NODES[7394].Fix(IS_STRUCTURE); -NODES[7397].Fix(IS_STRUCTURE); -NODES[7398].Fix(IS_STRUCTURE); -NODES[7399].Fix(IS_STRUCTURE); -NODES[7400].Fix(IS_STRUCTURE); -NODES[7404].Fix(IS_STRUCTURE); -NODES[7405].Fix(IS_STRUCTURE); -NODES[7412].Fix(IS_STRUCTURE); -NODES[7414].Fix(IS_STRUCTURE); -NODES[7415].Fix(IS_STRUCTURE); -NODES[7423].Fix(IS_STRUCTURE); -NODES[7430].Fix(IS_STRUCTURE); -NODES[7434].Fix(IS_STRUCTURE); -NODES[7435].Fix(IS_STRUCTURE); -NODES[7436].Fix(IS_STRUCTURE); -NODES[7437].Fix(IS_STRUCTURE); -NODES[7438].Fix(IS_STRUCTURE); -NODES[7439].Fix(IS_STRUCTURE); -NODES[7440].Fix(IS_STRUCTURE); -NODES[7441].Fix(IS_STRUCTURE); -NODES[7444].Fix(IS_STRUCTURE); -NODES[7449].Fix(IS_STRUCTURE); -NODES[7453].Fix(IS_STRUCTURE); -NODES[7455].Fix(IS_STRUCTURE); -NODES[7462].Fix(IS_STRUCTURE); -NODES[7463].Fix(IS_STRUCTURE); -NODES[7464].Fix(IS_STRUCTURE); -NODES[7469].Fix(IS_STRUCTURE); -NODES[7473].Fix(IS_STRUCTURE); -NODES[7474].Fix(IS_STRUCTURE); -NODES[7476].Fix(IS_STRUCTURE); -NODES[7479].Fix(IS_STRUCTURE); -NODES[7480].Fix(IS_STRUCTURE); -NODES[7481].Fix(IS_STRUCTURE); -NODES[7503].Fix(IS_STRUCTURE); -NODES[7504].Fix(IS_STRUCTURE); -NODES[7506].Fix(IS_STRUCTURE); -NODES[7518].Fix(IS_STRUCTURE); -NODES[7521].Fix(IS_STRUCTURE); -NODES[7522].Fix(IS_STRUCTURE); -NODES[7527].Fix(IS_STRUCTURE); -NODES[7528].Fix(IS_STRUCTURE); -NODES[7530].Fix(IS_STRUCTURE); -NODES[7531].Fix(IS_STRUCTURE); -NODES[7533].Fix(IS_STRUCTURE); -NODES[7534].Fix(IS_STRUCTURE); -NODES[7546].Fix(IS_STRUCTURE); -NODES[7547].Fix(IS_STRUCTURE); -NODES[7548].Fix(IS_STRUCTURE); -NODES[7549].Fix(IS_STRUCTURE); -NODES[7552].Fix(IS_STRUCTURE); -NODES[7561].Fix(IS_STRUCTURE); -NODES[7562].Fix(IS_STRUCTURE); -NODES[7563].Fix(IS_STRUCTURE); -NODES[7564].Fix(IS_STRUCTURE); -NODES[7565].Fix(IS_STRUCTURE); -NODES[7570].Fix(IS_STRUCTURE); -NODES[7575].Fix(IS_STRUCTURE); -NODES[7576].Fix(IS_STRUCTURE); -NODES[7577].Fix(IS_STRUCTURE); -NODES[7592].Fix(IS_STRUCTURE); -NODES[7596].Fix(IS_STRUCTURE); -NODES[7620].Fix(IS_STRUCTURE); -NODES[7625].Fix(IS_STRUCTURE); -NODES[7630].Fix(IS_STRUCTURE); -NODES[7631].Fix(IS_STRUCTURE); -NODES[7636].Fix(IS_STRUCTURE); -NODES[7637].Fix(IS_STRUCTURE); -NODES[7638].Fix(IS_STRUCTURE); -NODES[7642].Fix(IS_STRUCTURE); -NODES[7643].Fix(IS_STRUCTURE); -NODES[7645].Fix(IS_STRUCTURE); -NODES[7646].Fix(IS_STRUCTURE); -NODES[7654].Fix(IS_STRUCTURE); -NODES[7656].Fix(IS_STRUCTURE); -NODES[7660].Fix(IS_STRUCTURE); -NODES[7670].Fix(IS_STRUCTURE); -NODES[7683].Fix(IS_STRUCTURE); -NODES[7684].Fix(IS_STRUCTURE); -NODES[7685].Fix(IS_STRUCTURE); -NODES[7686].Fix(IS_STRUCTURE); -NODES[7687].Fix(IS_STRUCTURE); -NODES[7688].Fix(IS_STRUCTURE); -NODES[7689].Fix(IS_STRUCTURE); -NODES[7694].Fix(IS_STRUCTURE); -NODES[7695].Fix(IS_STRUCTURE); -NODES[7697].Fix(IS_STRUCTURE); -NODES[7700].Fix(IS_STRUCTURE); -NODES[7702].Fix(IS_STRUCTURE); -NODES[7708].Fix(IS_STRUCTURE); -NODES[7709].Fix(IS_STRUCTURE); -NODES[7710].Fix(IS_STRUCTURE); -NODES[7718].Fix(IS_STRUCTURE); -NODES[7729].Fix(IS_STRUCTURE); -NODES[7735].Fix(IS_STRUCTURE); -NODES[7736].Fix(IS_STRUCTURE); -NODES[7738].Fix(IS_STRUCTURE); -NODES[7739].Fix(IS_STRUCTURE); -NODES[7748].Fix(IS_STRUCTURE); -NODES[7751].Fix(IS_STRUCTURE); -NODES[7752].Fix(IS_STRUCTURE); -NODES[7758].Fix(IS_STRUCTURE); -NODES[7759].Fix(IS_STRUCTURE); -NODES[7765].Fix(IS_STRUCTURE); -NODES[7766].Fix(IS_STRUCTURE); -NODES[7770].Fix(IS_STRUCTURE); -NODES[7774].Fix(IS_STRUCTURE); -NODES[7782].Fix(IS_STRUCTURE); -NODES[7792].Fix(IS_STRUCTURE); -NODES[7793].Fix(IS_STRUCTURE); -NODES[7796].Fix(IS_STRUCTURE); -NODES[7797].Fix(IS_STRUCTURE); -NODES[7798].Fix(IS_STRUCTURE); -NODES[7799].Fix(IS_STRUCTURE); -NODES[7800].Fix(IS_STRUCTURE); -NODES[7801].Fix(IS_STRUCTURE); -NODES[7802].Fix(IS_STRUCTURE); -NODES[7816].Fix(IS_STRUCTURE); -NODES[7824].Fix(IS_STRUCTURE); -NODES[7830].Fix(IS_STRUCTURE); -NODES[7834].Fix(IS_STRUCTURE); -NODES[7835].Fix(IS_STRUCTURE); -NODES[7846].Fix(IS_STRUCTURE); -NODES[7857].Fix(IS_STRUCTURE); -NODES[7859].Fix(IS_STRUCTURE); -NODES[7865].Fix(IS_STRUCTURE); -NODES[7876].Fix(IS_STRUCTURE); -NODES[7877].Fix(IS_STRUCTURE); -NODES[7878].Fix(IS_STRUCTURE); -NODES[7879].Fix(IS_STRUCTURE); -NODES[7884].Fix(IS_STRUCTURE); -NODES[7885].Fix(IS_STRUCTURE); -NODES[7891].Fix(IS_STRUCTURE); -NODES[7896].Fix(IS_STRUCTURE); -NODES[7901].Fix(IS_STRUCTURE); -NODES[7902].Fix(IS_STRUCTURE); -NODES[7906].Fix(IS_STRUCTURE); -NODES[7913].Fix(IS_STRUCTURE); -NODES[7915].Fix(IS_STRUCTURE); -NODES[7933].Fix(IS_STRUCTURE); -NODES[7945].Fix(IS_STRUCTURE); -NODES[7946].Fix(IS_STRUCTURE); -NODES[7947].Fix(IS_STRUCTURE); -NODES[7948].Fix(IS_STRUCTURE); -NODES[7949].Fix(IS_STRUCTURE); -NODES[7956].Fix(IS_STRUCTURE); -NODES[7963].Fix(IS_STRUCTURE); -NODES[7964].Fix(IS_STRUCTURE); -NODES[7986].Fix(IS_STRUCTURE); -NODES[7987].Fix(IS_STRUCTURE); -NODES[7988].Fix(IS_STRUCTURE); -NODES[7989].Fix(IS_STRUCTURE); -NODES[7999].Fix(IS_STRUCTURE); -NODES[8003].Fix(IS_STRUCTURE); -NODES[8004].Fix(IS_STRUCTURE); -NODES[8005].Fix(IS_STRUCTURE); -NODES[8008].Fix(IS_STRUCTURE); -NODES[8011].Fix(IS_STRUCTURE); -NODES[8016].Fix(IS_STRUCTURE); -NODES[8025].Fix(IS_STRUCTURE); -NODES[8026].Fix(IS_STRUCTURE); -NODES[8031].Fix(IS_STRUCTURE); -NODES[8037].Fix(IS_STRUCTURE); -NODES[8038].Fix(IS_STRUCTURE); -NODES[8039].Fix(IS_STRUCTURE); -NODES[8040].Fix(IS_STRUCTURE); -NODES[8041].Fix(IS_STRUCTURE); -NODES[8047].Fix(IS_STRUCTURE); -NODES[8059].Fix(IS_STRUCTURE); -NODES[8060].Fix(IS_STRUCTURE); -NODES[8061].Fix(IS_STRUCTURE); -NODES[8077].Fix(IS_STRUCTURE); -NODES[8086].Fix(IS_STRUCTURE); -NODES[8087].Fix(IS_STRUCTURE); -NODES[8088].Fix(IS_STRUCTURE); -NODES[8092].Fix(IS_STRUCTURE); -NODES[8099].Fix(IS_STRUCTURE); -NODES[8100].Fix(IS_STRUCTURE); -NODES[8101].Fix(IS_STRUCTURE); -NODES[8107].Fix(IS_STRUCTURE); -NODES[8108].Fix(IS_STRUCTURE); -NODES[8113].Fix(IS_STRUCTURE); -NODES[8118].Fix(IS_STRUCTURE); -NODES[8119].Fix(IS_STRUCTURE); -NODES[8123].Fix(IS_STRUCTURE); -NODES[8126].Fix(IS_STRUCTURE); -NODES[8127].Fix(IS_STRUCTURE); -NODES[8129].Fix(IS_STRUCTURE); -NODES[8130].Fix(IS_STRUCTURE); -NODES[8131].Fix(IS_STRUCTURE); -NODES[8135].Fix(IS_STRUCTURE); -NODES[8145].Fix(IS_STRUCTURE); -NODES[8146].Fix(IS_STRUCTURE); -NODES[8150].Fix(IS_STRUCTURE); -NODES[8159].Fix(IS_STRUCTURE); -NODES[8167].Fix(IS_STRUCTURE); -NODES[8168].Fix(IS_STRUCTURE); -NODES[8171].Fix(IS_STRUCTURE); -NODES[8172].Fix(IS_STRUCTURE); -NODES[8173].Fix(IS_STRUCTURE); -NODES[8175].Fix(IS_STRUCTURE); -NODES[8177].Fix(IS_STRUCTURE); -NODES[8179].Fix(IS_STRUCTURE); -NODES[8183].Fix(IS_STRUCTURE); -NODES[8186].Fix(IS_STRUCTURE); -NODES[8191].Fix(IS_STRUCTURE); -NODES[8200].Fix(IS_STRUCTURE); -NODES[8214].Fix(IS_STRUCTURE); -NODES[8215].Fix(IS_STRUCTURE); -NODES[8229].Fix(IS_STRUCTURE); -NODES[8234].Fix(IS_STRUCTURE); -NODES[8235].Fix(IS_STRUCTURE); -NODES[8236].Fix(IS_STRUCTURE); -NODES[8237].Fix(IS_STRUCTURE); -NODES[8238].Fix(IS_STRUCTURE); -NODES[8239].Fix(IS_STRUCTURE); -NODES[8240].Fix(IS_STRUCTURE); -NODES[8241].Fix(IS_STRUCTURE); -NODES[8242].Fix(IS_STRUCTURE); -NODES[8248].Fix(IS_STRUCTURE); -NODES[8253].Fix(IS_STRUCTURE); -NODES[8254].Fix(IS_STRUCTURE); -NODES[8255].Fix(IS_STRUCTURE); -NODES[8262].Fix(IS_STRUCTURE); -NODES[8263].Fix(IS_STRUCTURE); -NODES[8264].Fix(IS_STRUCTURE); -NODES[8267].Fix(IS_STRUCTURE); -NODES[8275].Fix(IS_STRUCTURE); -NODES[8277].Fix(IS_STRUCTURE); -NODES[8278].Fix(IS_STRUCTURE); -NODES[8279].Fix(IS_STRUCTURE); -NODES[8280].Fix(IS_STRUCTURE); -NODES[8285].Fix(IS_STRUCTURE); -NODES[8286].Fix(IS_STRUCTURE); -NODES[8287].Fix(IS_STRUCTURE); -NODES[8293].Fix(IS_STRUCTURE); -NODES[8301].Fix(IS_STRUCTURE); -NODES[8313].Fix(IS_STRUCTURE); -NODES[8315].Fix(IS_STRUCTURE); -NODES[8316].Fix(IS_STRUCTURE); -NODES[8317].Fix(IS_STRUCTURE); -NODES[8319].Fix(IS_STRUCTURE); -NODES[8320].Fix(IS_STRUCTURE); -NODES[8328].Fix(IS_STRUCTURE); -NODES[8352].Fix(IS_STRUCTURE); -NODES[8356].Fix(IS_STRUCTURE); -NODES[8357].Fix(IS_STRUCTURE); -NODES[8363].Fix(IS_STRUCTURE); -NODES[8371].Fix(IS_STRUCTURE); -NODES[8377].Fix(IS_STRUCTURE); -NODES[8390].Fix(IS_STRUCTURE); -NODES[8391].Fix(IS_STRUCTURE); -NODES[8392].Fix(IS_STRUCTURE); -NODES[8393].Fix(IS_STRUCTURE); -NODES[8394].Fix(IS_STRUCTURE); -NODES[8400].Fix(IS_STRUCTURE); -NODES[8401].Fix(IS_STRUCTURE); -NODES[8403].Fix(IS_STRUCTURE); -NODES[8407].Fix(IS_STRUCTURE); -NODES[8408].Fix(IS_STRUCTURE); -NODES[8419].Fix(IS_STRUCTURE); -NODES[8420].Fix(IS_STRUCTURE); -NODES[8421].Fix(IS_STRUCTURE); -NODES[8422].Fix(IS_STRUCTURE); -NODES[8434].Fix(IS_STRUCTURE); -NODES[8435].Fix(IS_STRUCTURE); -NODES[8436].Fix(IS_STRUCTURE); -NODES[8443].Fix(IS_STRUCTURE); -NODES[8445].Fix(IS_STRUCTURE); -NODES[8454].Fix(IS_STRUCTURE); -NODES[8456].Fix(IS_STRUCTURE); -NODES[8472].Fix(IS_STRUCTURE); -NODES[8476].Fix(IS_STRUCTURE); -NODES[8480].Fix(IS_STRUCTURE); -NODES[8481].Fix(IS_STRUCTURE); -NODES[8482].Fix(IS_STRUCTURE); -NODES[8490].Fix(IS_STRUCTURE); -NODES[8504].Fix(IS_STRUCTURE); -NODES[8508].Fix(IS_STRUCTURE); -NODES[8513].Fix(IS_STRUCTURE); -NODES[8516].Fix(IS_STRUCTURE); -NODES[8521].Fix(IS_STRUCTURE); -NODES[8526].Fix(IS_STRUCTURE); -NODES[8527].Fix(IS_STRUCTURE); -NODES[8528].Fix(IS_STRUCTURE); -NODES[8539].Fix(IS_STRUCTURE); -NODES[8544].Fix(IS_STRUCTURE); -NODES[8553].Fix(IS_STRUCTURE); -NODES[8554].Fix(IS_STRUCTURE); -NODES[8555].Fix(IS_STRUCTURE); -NODES[8557].Fix(IS_STRUCTURE); -NODES[8558].Fix(IS_STRUCTURE); -NODES[8559].Fix(IS_STRUCTURE); -NODES[8560].Fix(IS_STRUCTURE); -NODES[8561].Fix(IS_STRUCTURE); -NODES[8562].Fix(IS_STRUCTURE); -NODES[8563].Fix(IS_STRUCTURE); -NODES[8564].Fix(IS_STRUCTURE); -NODES[8565].Fix(IS_STRUCTURE); -NODES[8571].Fix(IS_STRUCTURE); -NODES[8572].Fix(IS_STRUCTURE); -NODES[8577].Fix(IS_STRUCTURE); -NODES[8579].Fix(IS_STRUCTURE); -NODES[8583].Fix(IS_STRUCTURE); -NODES[8600].Fix(IS_STRUCTURE); -NODES[8601].Fix(IS_STRUCTURE); -NODES[8602].Fix(IS_STRUCTURE); -NODES[8609].Fix(IS_STRUCTURE); -NODES[8611].Fix(IS_STRUCTURE); -NODES[8617].Fix(IS_STRUCTURE); -NODES[8624].Fix(IS_STRUCTURE); -NODES[8625].Fix(IS_STRUCTURE); -NODES[8626].Fix(IS_STRUCTURE); -NODES[8630].Fix(IS_STRUCTURE); -NODES[8632].Fix(IS_STRUCTURE); -NODES[8637].Fix(IS_STRUCTURE); -NODES[8652].Fix(IS_STRUCTURE); -NODES[8662].Fix(IS_STRUCTURE); -NODES[8679].Fix(IS_STRUCTURE); -NODES[8681].Fix(IS_STRUCTURE); -NODES[8690].Fix(IS_STRUCTURE); -NODES[8697].Fix(IS_STRUCTURE); -NODES[8700].Fix(IS_STRUCTURE); -NODES[8701].Fix(IS_STRUCTURE); -NODES[8703].Fix(IS_STRUCTURE); -NODES[8705].Fix(IS_STRUCTURE); -NODES[8713].Fix(IS_STRUCTURE); -NODES[8715].Fix(IS_STRUCTURE); -NODES[8716].Fix(IS_STRUCTURE); -NODES[8717].Fix(IS_STRUCTURE); -NODES[8719].Fix(IS_STRUCTURE); -NODES[8724].Fix(IS_STRUCTURE); -NODES[8725].Fix(IS_STRUCTURE); -NODES[8730].Fix(IS_STRUCTURE); -NODES[8732].Fix(IS_STRUCTURE); -NODES[8733].Fix(IS_STRUCTURE); -NODES[8738].Fix(IS_STRUCTURE); -NODES[8744].Fix(IS_STRUCTURE); -NODES[8760].Fix(IS_STRUCTURE); -NODES[8761].Fix(IS_STRUCTURE); -NODES[8762].Fix(IS_STRUCTURE); -NODES[8780].Fix(IS_STRUCTURE); -NODES[8782].Fix(IS_STRUCTURE); -NODES[8787].Fix(IS_STRUCTURE); -NODES[8802].Fix(IS_STRUCTURE); -NODES[8812].Fix(IS_STRUCTURE); -NODES[8824].Fix(IS_STRUCTURE); -NODES[8825].Fix(IS_STRUCTURE); -NODES[8826].Fix(IS_STRUCTURE); -NODES[8827].Fix(IS_STRUCTURE); -NODES[8828].Fix(IS_STRUCTURE); -NODES[8836].Fix(IS_STRUCTURE); -NODES[8853].Fix(IS_STRUCTURE); -NODES[8856].Fix(IS_STRUCTURE); -NODES[8857].Fix(IS_STRUCTURE); -NODES[8862].Fix(IS_STRUCTURE); -NODES[8868].Fix(IS_STRUCTURE); -NODES[8870].Fix(IS_STRUCTURE); -NODES[8872].Fix(IS_STRUCTURE); -NODES[8873].Fix(IS_STRUCTURE); -NODES[8879].Fix(IS_STRUCTURE); -NODES[8887].Fix(IS_STRUCTURE); -NODES[8888].Fix(IS_STRUCTURE); -NODES[8892].Fix(IS_STRUCTURE); -NODES[8893].Fix(IS_STRUCTURE); -NODES[8894].Fix(IS_STRUCTURE); -NODES[8896].Fix(IS_STRUCTURE); -NODES[8899].Fix(IS_STRUCTURE); -NODES[8900].Fix(IS_STRUCTURE); -NODES[8901].Fix(IS_STRUCTURE); -NODES[8904].Fix(IS_STRUCTURE); -NODES[8921].Fix(IS_STRUCTURE); -NODES[8922].Fix(IS_STRUCTURE); -NODES[8924].Fix(IS_STRUCTURE); -NODES[8930].Fix(IS_STRUCTURE); -NODES[8931].Fix(IS_STRUCTURE); -NODES[8932].Fix(IS_STRUCTURE); -NODES[8937].Fix(IS_STRUCTURE); -NODES[8938].Fix(IS_STRUCTURE); -NODES[8939].Fix(IS_STRUCTURE); -NODES[8940].Fix(IS_STRUCTURE); -NODES[8941].Fix(IS_STRUCTURE); -NODES[8942].Fix(IS_STRUCTURE); -NODES[8943].Fix(IS_STRUCTURE); -NODES[8944].Fix(IS_STRUCTURE); -NODES[8953].Fix(IS_STRUCTURE); -NODES[8967].Fix(IS_STRUCTURE); -NODES[8972].Fix(IS_STRUCTURE); -NODES[8973].Fix(IS_STRUCTURE); -NODES[8974].Fix(IS_STRUCTURE); -NODES[8975].Fix(IS_STRUCTURE); -NODES[8980].Fix(IS_STRUCTURE); -NODES[8983].Fix(IS_STRUCTURE); -NODES[8984].Fix(IS_STRUCTURE); -NODES[8985].Fix(IS_STRUCTURE); -NODES[8986].Fix(IS_STRUCTURE); -NODES[8992].Fix(IS_STRUCTURE); -NODES[8993].Fix(IS_STRUCTURE); -NODES[9006].Fix(IS_STRUCTURE); -NODES[9007].Fix(IS_STRUCTURE); -NODES[9010].Fix(IS_STRUCTURE); -NODES[9018].Fix(IS_STRUCTURE); -NODES[9023].Fix(IS_STRUCTURE); -NODES[9025].Fix(IS_STRUCTURE); -NODES[9026].Fix(IS_STRUCTURE); -NODES[9031].Fix(IS_STRUCTURE); -NODES[9048].Fix(IS_STRUCTURE); -NODES[9049].Fix(IS_STRUCTURE); -NODES[9056].Fix(IS_STRUCTURE); -NODES[9059].Fix(IS_STRUCTURE); -NODES[9060].Fix(IS_STRUCTURE); -NODES[9066].Fix(IS_STRUCTURE); -NODES[9071].Fix(IS_STRUCTURE); -NODES[9076].Fix(IS_STRUCTURE); -NODES[9077].Fix(IS_STRUCTURE); -NODES[9078].Fix(IS_STRUCTURE); -NODES[9092].Fix(IS_STRUCTURE); -NODES[9100].Fix(IS_STRUCTURE); -NODES[9101].Fix(IS_STRUCTURE); -NODES[9122].Fix(IS_STRUCTURE); -NODES[9123].Fix(IS_STRUCTURE); -NODES[9124].Fix(IS_STRUCTURE); -NODES[9125].Fix(IS_STRUCTURE); -NODES[9134].Fix(IS_STRUCTURE); -NODES[9136].Fix(IS_STRUCTURE); -NODES[9137].Fix(IS_STRUCTURE); -NODES[9147].Fix(IS_STRUCTURE); -NODES[9154].Fix(IS_STRUCTURE); -NODES[9155].Fix(IS_STRUCTURE); -NODES[9158].Fix(IS_STRUCTURE); -NODES[9159].Fix(IS_STRUCTURE); -NODES[9162].Fix(IS_STRUCTURE); -NODES[9163].Fix(IS_STRUCTURE); -NODES[9166].Fix(IS_STRUCTURE); -NODES[9167].Fix(IS_STRUCTURE); -NODES[9168].Fix(IS_STRUCTURE); -NODES[9172].Fix(IS_STRUCTURE); -NODES[9188].Fix(IS_STRUCTURE); -NODES[9193].Fix(IS_STRUCTURE); -NODES[9194].Fix(IS_STRUCTURE); -NODES[9195].Fix(IS_STRUCTURE); -NODES[9196].Fix(IS_STRUCTURE); -NODES[9197].Fix(IS_STRUCTURE); -NODES[9198].Fix(IS_STRUCTURE); -NODES[9199].Fix(IS_STRUCTURE); -NODES[9218].Fix(IS_STRUCTURE); -NODES[9222].Fix(IS_STRUCTURE); -NODES[9232].Fix(IS_STRUCTURE); -NODES[9233].Fix(IS_STRUCTURE); -NODES[9245].Fix(IS_STRUCTURE); -NODES[9248].Fix(IS_STRUCTURE); -NODES[9249].Fix(IS_STRUCTURE); -NODES[9250].Fix(IS_STRUCTURE); -NODES[9251].Fix(IS_STRUCTURE); -NODES[9254].Fix(IS_STRUCTURE); -NODES[9256].Fix(IS_STRUCTURE); -NODES[9272].Fix(IS_STRUCTURE); -NODES[9273].Fix(IS_STRUCTURE); -NODES[9275].Fix(IS_STRUCTURE); -NODES[9277].Fix(IS_STRUCTURE); -NODES[9278].Fix(IS_STRUCTURE); -NODES[9282].Fix(IS_STRUCTURE); -NODES[9283].Fix(IS_STRUCTURE); -NODES[9291].Fix(IS_STRUCTURE); -NODES[9292].Fix(IS_STRUCTURE); -NODES[9300].Fix(IS_STRUCTURE); -NODES[9301].Fix(IS_STRUCTURE); -NODES[9302].Fix(IS_STRUCTURE); -NODES[9303].Fix(IS_STRUCTURE); -NODES[9304].Fix(IS_STRUCTURE); -NODES[9305].Fix(IS_STRUCTURE); -NODES[9315].Fix(IS_STRUCTURE); -NODES[9318].Fix(IS_STRUCTURE); -NODES[9324].Fix(IS_STRUCTURE); -NODES[9326].Fix(IS_STRUCTURE); -NODES[9332].Fix(IS_STRUCTURE); -NODES[9339].Fix(IS_STRUCTURE); -NODES[9342].Fix(IS_STRUCTURE); -NODES[9343].Fix(IS_STRUCTURE); -NODES[9344].Fix(IS_STRUCTURE); -NODES[9345].Fix(IS_STRUCTURE); -NODES[9346].Fix(IS_STRUCTURE); -NODES[9347].Fix(IS_STRUCTURE); -NODES[9349].Fix(IS_STRUCTURE); -NODES[9369].Fix(IS_STRUCTURE); -NODES[9370].Fix(IS_STRUCTURE); -NODES[9380].Fix(IS_STRUCTURE); -NODES[9388].Fix(IS_STRUCTURE); -NODES[9394].Fix(IS_STRUCTURE); -NODES[9405].Fix(IS_STRUCTURE); -NODES[9422].Fix(IS_STRUCTURE); -NODES[9423].Fix(IS_STRUCTURE); -NODES[9425].Fix(IS_STRUCTURE); -NODES[9432].Fix(IS_STRUCTURE); -NODES[9435].Fix(IS_STRUCTURE); -NODES[9436].Fix(IS_STRUCTURE); -NODES[9449].Fix(IS_STRUCTURE); -NODES[9450].Fix(IS_STRUCTURE); -NODES[9453].Fix(IS_STRUCTURE); -NODES[9454].Fix(IS_STRUCTURE); -NODES[9490].Fix(IS_STRUCTURE); -NODES[9494].Fix(IS_STRUCTURE); -NODES[9496].Fix(IS_STRUCTURE); -NODES[9497].Fix(IS_STRUCTURE); -NODES[9507].Fix(IS_STRUCTURE); -NODES[9515].Fix(IS_STRUCTURE); -NODES[9521].Fix(IS_STRUCTURE); -NODES[9522].Fix(IS_STRUCTURE); -NODES[9523].Fix(IS_STRUCTURE); -NODES[9524].Fix(IS_STRUCTURE); -NODES[9525].Fix(IS_STRUCTURE); -NODES[9526].Fix(IS_STRUCTURE); -NODES[9537].Fix(IS_STRUCTURE); -NODES[9539].Fix(IS_STRUCTURE); -NODES[9541].Fix(IS_STRUCTURE); -NODES[9547].Fix(IS_STRUCTURE); -NODES[9557].Fix(IS_STRUCTURE); -NODES[9558].Fix(IS_STRUCTURE); -NODES[9561].Fix(IS_STRUCTURE); -NODES[9562].Fix(IS_STRUCTURE); -NODES[9563].Fix(IS_STRUCTURE); -NODES[9578].Fix(IS_STRUCTURE); -NODES[9579].Fix(IS_STRUCTURE); -NODES[9580].Fix(IS_STRUCTURE); -NODES[9586].Fix(IS_STRUCTURE); -NODES[9600].Fix(IS_STRUCTURE); -NODES[9605].Fix(IS_STRUCTURE); -NODES[9606].Fix(IS_STRUCTURE); -NODES[9624].Fix(IS_STRUCTURE); -NODES[9625].Fix(IS_STRUCTURE); -NODES[9626].Fix(IS_STRUCTURE); -NODES[9632].Fix(IS_STRUCTURE); -NODES[9639].Fix(IS_STRUCTURE); -NODES[9643].Fix(IS_STRUCTURE); -NODES[9650].Fix(IS_STRUCTURE); -NODES[9651].Fix(IS_STRUCTURE); -NODES[9654].Fix(IS_STRUCTURE); -NODES[9656].Fix(IS_STRUCTURE); -NODES[9670].Fix(IS_STRUCTURE); -NODES[9671].Fix(IS_STRUCTURE); -NODES[9694].Fix(IS_STRUCTURE); -NODES[9700].Fix(IS_STRUCTURE); -NODES[9711].Fix(IS_STRUCTURE); -NODES[9716].Fix(IS_STRUCTURE); -NODES[9718].Fix(IS_STRUCTURE); -NODES[9719].Fix(IS_STRUCTURE); -NODES[9721].Fix(IS_STRUCTURE); -NODES[9726].Fix(IS_STRUCTURE); -NODES[9727].Fix(IS_STRUCTURE); -NODES[9728].Fix(IS_STRUCTURE); -NODES[9729].Fix(IS_STRUCTURE); -NODES[9730].Fix(IS_STRUCTURE); -NODES[9731].Fix(IS_STRUCTURE); -NODES[9732].Fix(IS_STRUCTURE); -NODES[9736].Fix(IS_STRUCTURE); -NODES[9737].Fix(IS_STRUCTURE); -NODES[9739].Fix(IS_STRUCTURE); -NODES[9740].Fix(IS_STRUCTURE); -NODES[9742].Fix(IS_STRUCTURE); -NODES[9743].Fix(IS_STRUCTURE); -NODES[9746].Fix(IS_STRUCTURE); -NODES[9749].Fix(IS_STRUCTURE); -NODES[9750].Fix(IS_STRUCTURE); -NODES[9757].Fix(IS_STRUCTURE); -NODES[9759].Fix(IS_STRUCTURE); -NODES[9763].Fix(IS_STRUCTURE); -NODES[9765].Fix(IS_STRUCTURE); -NODES[9767].Fix(IS_STRUCTURE); -NODES[9768].Fix(IS_STRUCTURE); -NODES[9769].Fix(IS_STRUCTURE); -NODES[9778].Fix(IS_STRUCTURE); -NODES[9783].Fix(IS_STRUCTURE); -NODES[9784].Fix(IS_STRUCTURE); -NODES[9789].Fix(IS_STRUCTURE); -NODES[9805].Fix(IS_STRUCTURE); -NODES[9810].Fix(IS_STRUCTURE); -NODES[9814].Fix(IS_STRUCTURE); -NODES[9829].Fix(IS_STRUCTURE); -NODES[9830].Fix(IS_STRUCTURE); -NODES[9831].Fix(IS_STRUCTURE); -NODES[9841].Fix(IS_STRUCTURE); -NODES[9842].Fix(IS_STRUCTURE); -NODES[9843].Fix(IS_STRUCTURE); -NODES[9844].Fix(IS_STRUCTURE); -NODES[9861].Fix(IS_STRUCTURE); -NODES[9864].Fix(IS_STRUCTURE); -NODES[9867].Fix(IS_STRUCTURE); -NODES[9868].Fix(IS_STRUCTURE); -NODES[9873].Fix(IS_STRUCTURE); -NODES[9874].Fix(IS_STRUCTURE); -NODES[9878].Fix(IS_STRUCTURE); -NODES[9879].Fix(IS_STRUCTURE); -NODES[9880].Fix(IS_STRUCTURE); -NODES[9881].Fix(IS_STRUCTURE); -NODES[9891].Fix(IS_STRUCTURE); -NODES[9897].Fix(IS_STRUCTURE); -NODES[9900].Fix(IS_STRUCTURE); -NODES[9915].Fix(IS_STRUCTURE); -NODES[9916].Fix(IS_STRUCTURE); -NODES[9921].Fix(IS_STRUCTURE); -NODES[9926].Fix(IS_STRUCTURE); -NODES[9930].Fix(IS_STRUCTURE); -NODES[9937].Fix(IS_STRUCTURE); -NODES[9938].Fix(IS_STRUCTURE); -NODES[9939].Fix(IS_STRUCTURE); -NODES[9946].Fix(IS_STRUCTURE); -NODES[9947].Fix(IS_STRUCTURE); -NODES[9948].Fix(IS_STRUCTURE); -NODES[9964].Fix(IS_STRUCTURE); -NODES[9975].Fix(IS_STRUCTURE); -NODES[9976].Fix(IS_STRUCTURE); -NODES[9978].Fix(IS_STRUCTURE); -NODES[9979].Fix(IS_STRUCTURE); -NODES[9981].Fix(IS_STRUCTURE); -NODES[9987].Fix(IS_STRUCTURE); -NODES[9988].Fix(IS_STRUCTURE); -NODES[9989].Fix(IS_STRUCTURE); -NODES[10011].Fix(IS_STRUCTURE); -NODES[10024].Fix(IS_STRUCTURE); -NODES[10025].Fix(IS_STRUCTURE); -NODES[10032].Fix(IS_STRUCTURE); -NODES[10039].Fix(IS_STRUCTURE); -NODES[10045].Fix(IS_STRUCTURE); -NODES[10046].Fix(IS_STRUCTURE); -NODES[10047].Fix(IS_STRUCTURE); -NODES[10052].Fix(IS_STRUCTURE); -NODES[10053].Fix(IS_STRUCTURE); -NODES[10060].Fix(IS_STRUCTURE); -NODES[10062].Fix(IS_STRUCTURE); -NODES[10063].Fix(IS_STRUCTURE); -NODES[10064].Fix(IS_STRUCTURE); -NODES[10067].Fix(IS_STRUCTURE); -NODES[10075].Fix(IS_STRUCTURE); -NODES[10081].Fix(IS_STRUCTURE); -NODES[10083].Fix(IS_STRUCTURE); -NODES[10095].Fix(IS_STRUCTURE); -NODES[10101].Fix(IS_STRUCTURE); -NODES[10111].Fix(IS_STRUCTURE); -NODES[10124].Fix(IS_STRUCTURE); -NODES[10125].Fix(IS_STRUCTURE); -NODES[10129].Fix(IS_STRUCTURE); -NODES[10136].Fix(IS_STRUCTURE); -NODES[10139].Fix(IS_STRUCTURE); -NODES[10140].Fix(IS_STRUCTURE); -NODES[10141].Fix(IS_STRUCTURE); -NODES[10150].Fix(IS_STRUCTURE); -NODES[10151].Fix(IS_STRUCTURE); -NODES[10161].Fix(IS_STRUCTURE); -NODES[10162].Fix(IS_STRUCTURE); -NODES[10163].Fix(IS_STRUCTURE); -NODES[10164].Fix(IS_STRUCTURE); -NODES[10165].Fix(IS_STRUCTURE); -NODES[10166].Fix(IS_STRUCTURE); -NODES[10172].Fix(IS_STRUCTURE); -NODES[10175].Fix(IS_STRUCTURE); -NODES[10176].Fix(IS_STRUCTURE); -NODES[10177].Fix(IS_STRUCTURE); -NODES[10183].Fix(IS_STRUCTURE); -NODES[10189].Fix(IS_STRUCTURE); -NODES[10196].Fix(IS_STRUCTURE); -NODES[10197].Fix(IS_STRUCTURE); -NODES[10198].Fix(IS_STRUCTURE); -NODES[10201].Fix(IS_STRUCTURE); -NODES[10203].Fix(IS_STRUCTURE); -NODES[10204].Fix(IS_STRUCTURE); -NODES[10223].Fix(IS_STRUCTURE); -NODES[10226].Fix(IS_STRUCTURE); -NODES[10227].Fix(IS_STRUCTURE); -NODES[10237].Fix(IS_STRUCTURE); -NODES[10246].Fix(IS_STRUCTURE); -NODES[10247].Fix(IS_STRUCTURE); -NODES[10251].Fix(IS_STRUCTURE); -NODES[10253].Fix(IS_STRUCTURE); -NODES[10259].Fix(IS_STRUCTURE); -NODES[10279].Fix(IS_STRUCTURE); -NODES[10280].Fix(IS_STRUCTURE); -NODES[10285].Fix(IS_STRUCTURE); -NODES[10286].Fix(IS_STRUCTURE); -NODES[10300].Fix(IS_STRUCTURE); -NODES[10301].Fix(IS_STRUCTURE); -NODES[10311].Fix(IS_STRUCTURE); -NODES[10312].Fix(IS_STRUCTURE); -NODES[10315].Fix(IS_STRUCTURE); -NODES[10328].Fix(IS_STRUCTURE); -NODES[10331].Fix(IS_STRUCTURE); -NODES[10332].Fix(IS_STRUCTURE); -NODES[10334].Fix(IS_STRUCTURE); -NODES[10341].Fix(IS_STRUCTURE); -NODES[10342].Fix(IS_STRUCTURE); -NODES[10348].Fix(IS_STRUCTURE); -NODES[10353].Fix(IS_STRUCTURE); -NODES[10355].Fix(IS_STRUCTURE); -NODES[10375].Fix(IS_STRUCTURE); -NODES[10379].Fix(IS_STRUCTURE); -NODES[10380].Fix(IS_STRUCTURE); -NODES[10385].Fix(IS_STRUCTURE); -NODES[10395].Fix(IS_STRUCTURE); -NODES[10411].Fix(IS_STRUCTURE); -NODES[10412].Fix(IS_STRUCTURE); -NODES[10415].Fix(IS_STRUCTURE); -NODES[10416].Fix(IS_STRUCTURE); -NODES[10417].Fix(IS_STRUCTURE); -NODES[10418].Fix(IS_STRUCTURE); -NODES[10423].Fix(IS_STRUCTURE); -NODES[10444].Fix(IS_STRUCTURE); -NODES[10445].Fix(IS_STRUCTURE); -NODES[10460].Fix(IS_STRUCTURE); -NODES[10481].Fix(IS_STRUCTURE); -NODES[10485].Fix(IS_STRUCTURE); -NODES[10489].Fix(IS_STRUCTURE); -NODES[10490].Fix(IS_STRUCTURE); -NODES[10491].Fix(IS_STRUCTURE); -NODES[10499].Fix(IS_STRUCTURE); -NODES[10505].Fix(IS_STRUCTURE); -NODES[10507].Fix(IS_STRUCTURE); -NODES[10508].Fix(IS_STRUCTURE); -NODES[10510].Fix(IS_STRUCTURE); -NODES[10513].Fix(IS_STRUCTURE); -NODES[10517].Fix(IS_STRUCTURE); -NODES[10518].Fix(IS_STRUCTURE); -NODES[10519].Fix(IS_STRUCTURE); -NODES[10521].Fix(IS_STRUCTURE); -NODES[10522].Fix(IS_STRUCTURE); -NODES[10523].Fix(IS_STRUCTURE); -NODES[10532].Fix(IS_STRUCTURE); -NODES[10547].Fix(IS_STRUCTURE); -NODES[10554].Fix(IS_STRUCTURE); -NODES[10565].Fix(IS_STRUCTURE); -NODES[10574].Fix(IS_STRUCTURE); -NODES[10578].Fix(IS_STRUCTURE); -NODES[10583].Fix(IS_STRUCTURE); -NODES[10584].Fix(IS_STRUCTURE); -NODES[10585].Fix(IS_STRUCTURE); -NODES[10588].Fix(IS_STRUCTURE); -NODES[10589].Fix(IS_STRUCTURE); -NODES[10598].Fix(IS_STRUCTURE); -NODES[10607].Fix(IS_STRUCTURE); -NODES[10608].Fix(IS_STRUCTURE); -NODES[10609].Fix(IS_STRUCTURE); -NODES[10610].Fix(IS_STRUCTURE); -NODES[10611].Fix(IS_STRUCTURE); -NODES[10616].Fix(IS_STRUCTURE); -NODES[10617].Fix(IS_STRUCTURE); -NODES[10620].Fix(IS_STRUCTURE); -NODES[10643].Fix(IS_STRUCTURE); -NODES[10644].Fix(IS_STRUCTURE); -NODES[10645].Fix(IS_STRUCTURE); -NODES[10646].Fix(IS_STRUCTURE); -NODES[10647].Fix(IS_STRUCTURE); -NODES[10648].Fix(IS_STRUCTURE); -NODES[10649].Fix(IS_STRUCTURE); -NODES[10650].Fix(IS_STRUCTURE); -NODES[10654].Fix(IS_STRUCTURE); -NODES[10663].Fix(IS_STRUCTURE); -NODES[10665].Fix(IS_STRUCTURE); -NODES[10667].Fix(IS_STRUCTURE); -NODES[10682].Fix(IS_STRUCTURE); -NODES[10683].Fix(IS_STRUCTURE); -NODES[10684].Fix(IS_STRUCTURE); -NODES[10685].Fix(IS_STRUCTURE); -NODES[10687].Fix(IS_STRUCTURE); -NODES[10691].Fix(IS_STRUCTURE); -NODES[10692].Fix(IS_STRUCTURE); -NODES[10693].Fix(IS_STRUCTURE); -NODES[10694].Fix(IS_STRUCTURE); -NODES[10710].Fix(IS_STRUCTURE); -NODES[10715].Fix(IS_STRUCTURE); -NODES[10721].Fix(IS_STRUCTURE); -NODES[10731].Fix(IS_STRUCTURE); -NODES[10732].Fix(IS_STRUCTURE); -NODES[10733].Fix(IS_STRUCTURE); -NODES[10734].Fix(IS_STRUCTURE); -NODES[10735].Fix(IS_STRUCTURE); -NODES[10736].Fix(IS_STRUCTURE); -NODES[10748].Fix(IS_STRUCTURE); -NODES[10751].Fix(IS_STRUCTURE); -NODES[10758].Fix(IS_STRUCTURE); -NODES[10759].Fix(IS_STRUCTURE); -NODES[10762].Fix(IS_STRUCTURE); -NODES[10763].Fix(IS_STRUCTURE); -NODES[10787].Fix(IS_STRUCTURE); -NODES[10792].Fix(IS_STRUCTURE); -NODES[10793].Fix(IS_STRUCTURE); -NODES[10798].Fix(IS_STRUCTURE); -NODES[10799].Fix(IS_STRUCTURE); -NODES[10802].Fix(IS_STRUCTURE); -NODES[10804].Fix(IS_STRUCTURE); -NODES[10808].Fix(IS_STRUCTURE); -NODES[10816].Fix(IS_STRUCTURE); -NODES[10827].Fix(IS_STRUCTURE); -NODES[10828].Fix(IS_STRUCTURE); -NODES[10832].Fix(IS_STRUCTURE); -NODES[10836].Fix(IS_STRUCTURE); -NODES[10842].Fix(IS_STRUCTURE); -NODES[10843].Fix(IS_STRUCTURE); -NODES[10863].Fix(IS_STRUCTURE); -NODES[10871].Fix(IS_STRUCTURE); -NODES[10877].Fix(IS_STRUCTURE); -NODES[10878].Fix(IS_STRUCTURE); -NODES[10879].Fix(IS_STRUCTURE); -NODES[10884].Fix(IS_STRUCTURE); -NODES[10885].Fix(IS_STRUCTURE); -NODES[10892].Fix(IS_STRUCTURE); -NODES[10913].Fix(IS_STRUCTURE); -NODES[10917].Fix(IS_STRUCTURE); -NODES[10929].Fix(IS_STRUCTURE); -NODES[10934].Fix(IS_STRUCTURE); -NODES[10935].Fix(IS_STRUCTURE); -NODES[10936].Fix(IS_STRUCTURE); -NODES[10938].Fix(IS_STRUCTURE); -NODES[10944].Fix(IS_STRUCTURE); -NODES[10947].Fix(IS_STRUCTURE); -NODES[10950].Fix(IS_STRUCTURE); -NODES[10952].Fix(IS_STRUCTURE); -NODES[10963].Fix(IS_STRUCTURE); -NODES[10971].Fix(IS_STRUCTURE); -NODES[10972].Fix(IS_STRUCTURE); -NODES[10979].Fix(IS_STRUCTURE); -NODES[10980].Fix(IS_STRUCTURE); -NODES[10991].Fix(IS_STRUCTURE); -NODES[10992].Fix(IS_STRUCTURE); -NODES[10995].Fix(IS_STRUCTURE); -NODES[10996].Fix(IS_STRUCTURE); -NODES[10997].Fix(IS_STRUCTURE); -NODES[11015].Fix(IS_STRUCTURE); -NODES[11017].Fix(IS_STRUCTURE); -NODES[11036].Fix(IS_STRUCTURE); -NODES[11047].Fix(IS_STRUCTURE); -NODES[11065].Fix(IS_STRUCTURE); -NODES[11075].Fix(IS_STRUCTURE); -NODES[11078].Fix(IS_STRUCTURE); -NODES[11090].Fix(IS_STRUCTURE); -NODES[11092].Fix(IS_STRUCTURE); -NODES[11093].Fix(IS_STRUCTURE); -NODES[11100].Fix(IS_STRUCTURE); -NODES[11101].Fix(IS_STRUCTURE); -NODES[11106].Fix(IS_STRUCTURE); -NODES[11107].Fix(IS_STRUCTURE); -NODES[11112].Fix(IS_STRUCTURE); -NODES[11113].Fix(IS_STRUCTURE); -NODES[11125].Fix(IS_STRUCTURE); -NODES[11126].Fix(IS_STRUCTURE); -NODES[11127].Fix(IS_STRUCTURE); -NODES[11137].Fix(IS_STRUCTURE); -NODES[11139].Fix(IS_STRUCTURE); -NODES[11140].Fix(IS_STRUCTURE); -NODES[11141].Fix(IS_STRUCTURE); -NODES[11142].Fix(IS_STRUCTURE); -NODES[11143].Fix(IS_STRUCTURE); -NODES[11151].Fix(IS_STRUCTURE); -NODES[11154].Fix(IS_STRUCTURE); -NODES[11155].Fix(IS_STRUCTURE); -NODES[11156].Fix(IS_STRUCTURE); -NODES[11157].Fix(IS_STRUCTURE); -NODES[11165].Fix(IS_STRUCTURE); -NODES[11176].Fix(IS_STRUCTURE); -NODES[11179].Fix(IS_STRUCTURE); -NODES[11180].Fix(IS_STRUCTURE); -NODES[11192].Fix(IS_STRUCTURE); -NODES[11193].Fix(IS_STRUCTURE); -NODES[11194].Fix(IS_STRUCTURE); -NODES[11195].Fix(IS_STRUCTURE); -NODES[11202].Fix(IS_STRUCTURE); -NODES[11213].Fix(IS_STRUCTURE); -NODES[11227].Fix(IS_STRUCTURE); -NODES[11247].Fix(IS_STRUCTURE); -NODES[11250].Fix(IS_STRUCTURE); -NODES[11251].Fix(IS_STRUCTURE); -NODES[11252].Fix(IS_STRUCTURE); -NODES[11262].Fix(IS_STRUCTURE); -NODES[11263].Fix(IS_STRUCTURE); -NODES[11264].Fix(IS_STRUCTURE); -NODES[11265].Fix(IS_STRUCTURE); -NODES[11266].Fix(IS_STRUCTURE); -NODES[11270].Fix(IS_STRUCTURE); -NODES[11302].Fix(IS_STRUCTURE); -NODES[11309].Fix(IS_STRUCTURE); -NODES[11319].Fix(IS_STRUCTURE); -NODES[11329].Fix(IS_STRUCTURE); -NODES[11334].Fix(IS_STRUCTURE); -NODES[11337].Fix(IS_STRUCTURE); -NODES[11338].Fix(IS_STRUCTURE); -NODES[11340].Fix(IS_STRUCTURE); -NODES[11343].Fix(IS_STRUCTURE); -NODES[11353].Fix(IS_STRUCTURE); -NODES[11354].Fix(IS_STRUCTURE); -NODES[11355].Fix(IS_STRUCTURE); -NODES[11356].Fix(IS_STRUCTURE); -NODES[11357].Fix(IS_STRUCTURE); -NODES[11361].Fix(IS_STRUCTURE); -NODES[11368].Fix(IS_STRUCTURE); -NODES[11370].Fix(IS_STRUCTURE); -NODES[11372].Fix(IS_STRUCTURE); -NODES[11384].Fix(IS_STRUCTURE); -NODES[11408].Fix(IS_STRUCTURE); -NODES[11414].Fix(IS_STRUCTURE); -NODES[11426].Fix(IS_STRUCTURE); -NODES[11427].Fix(IS_STRUCTURE); -NODES[11431].Fix(IS_STRUCTURE); -NODES[11437].Fix(IS_STRUCTURE); -NODES[11464].Fix(IS_STRUCTURE); -NODES[11465].Fix(IS_STRUCTURE); -NODES[11466].Fix(IS_STRUCTURE); -NODES[11467].Fix(IS_STRUCTURE); -NODES[11468].Fix(IS_STRUCTURE); -NODES[11469].Fix(IS_STRUCTURE); -NODES[11471].Fix(IS_STRUCTURE); -NODES[11472].Fix(IS_STRUCTURE); -NODES[11476].Fix(IS_STRUCTURE); -NODES[11486].Fix(IS_STRUCTURE); -NODES[11487].Fix(IS_STRUCTURE); -NODES[11491].Fix(IS_STRUCTURE); -NODES[11493].Fix(IS_STRUCTURE); -NODES[11494].Fix(IS_STRUCTURE); -NODES[11502].Fix(IS_STRUCTURE); -NODES[11507].Fix(IS_STRUCTURE); -NODES[11510].Fix(IS_STRUCTURE); -NODES[11513].Fix(IS_STRUCTURE); -NODES[11527].Fix(IS_STRUCTURE); -NODES[11528].Fix(IS_STRUCTURE); -NODES[11531].Fix(IS_STRUCTURE); -NODES[11550].Fix(IS_STRUCTURE); -NODES[11563].Fix(IS_STRUCTURE); -NODES[11564].Fix(IS_STRUCTURE); -NODES[11569].Fix(IS_STRUCTURE); -NODES[11574].Fix(IS_STRUCTURE); -NODES[11584].Fix(IS_STRUCTURE); -NODES[11585].Fix(IS_STRUCTURE); -NODES[11586].Fix(IS_STRUCTURE); -NODES[11596].Fix(IS_STRUCTURE); -NODES[11597].Fix(IS_STRUCTURE); -NODES[11598].Fix(IS_STRUCTURE); -NODES[11599].Fix(IS_STRUCTURE); -NODES[11600].Fix(IS_STRUCTURE); -NODES[11606].Fix(IS_STRUCTURE); -NODES[11624].Fix(IS_STRUCTURE); -NODES[11625].Fix(IS_STRUCTURE); -NODES[11626].Fix(IS_STRUCTURE); -NODES[11627].Fix(IS_STRUCTURE); -NODES[11633].Fix(IS_STRUCTURE); -NODES[11642].Fix(IS_STRUCTURE); -NODES[11644].Fix(IS_STRUCTURE); -NODES[11651].Fix(IS_STRUCTURE); -NODES[11655].Fix(IS_STRUCTURE); -NODES[11659].Fix(IS_STRUCTURE); -NODES[11660].Fix(IS_STRUCTURE); -NODES[11661].Fix(IS_STRUCTURE); -NODES[11662].Fix(IS_STRUCTURE); -NODES[11667].Fix(IS_STRUCTURE); -NODES[11677].Fix(IS_STRUCTURE); -NODES[11678].Fix(IS_STRUCTURE); -NODES[11679].Fix(IS_STRUCTURE); -NODES[11684].Fix(IS_STRUCTURE); -NODES[11685].Fix(IS_STRUCTURE); -NODES[11695].Fix(IS_STRUCTURE); -NODES[11700].Fix(IS_STRUCTURE); -NODES[11711].Fix(IS_STRUCTURE); -NODES[11720].Fix(IS_STRUCTURE); -NODES[11734].Fix(IS_STRUCTURE); -NODES[11736].Fix(IS_STRUCTURE); -NODES[11738].Fix(IS_STRUCTURE); -NODES[11740].Fix(IS_STRUCTURE); -NODES[11751].Fix(IS_STRUCTURE); -NODES[11752].Fix(IS_STRUCTURE); -NODES[11753].Fix(IS_STRUCTURE); -NODES[11754].Fix(IS_STRUCTURE); -NODES[11761].Fix(IS_STRUCTURE); -NODES[11792].Fix(IS_STRUCTURE); -NODES[11793].Fix(IS_STRUCTURE); -NODES[11803].Fix(IS_STRUCTURE); -NODES[11806].Fix(IS_STRUCTURE); -NODES[11817].Fix(IS_STRUCTURE); -NODES[11822].Fix(IS_STRUCTURE); -NODES[11826].Fix(IS_STRUCTURE); -NODES[11827].Fix(IS_STRUCTURE); -NODES[11828].Fix(IS_STRUCTURE); -NODES[11831].Fix(IS_STRUCTURE); -NODES[11836].Fix(IS_STRUCTURE); -NODES[11845].Fix(IS_STRUCTURE); -NODES[11846].Fix(IS_STRUCTURE); -NODES[11865].Fix(IS_STRUCTURE); -NODES[11867].Fix(IS_STRUCTURE); -NODES[11873].Fix(IS_STRUCTURE); -NODES[11877].Fix(IS_STRUCTURE); -NODES[11910].Fix(IS_STRUCTURE); -NODES[11915].Fix(IS_STRUCTURE); -NODES[11916].Fix(IS_STRUCTURE); -NODES[11919].Fix(IS_STRUCTURE); -NODES[11937].Fix(IS_STRUCTURE); -NODES[11938].Fix(IS_STRUCTURE); -NODES[11939].Fix(IS_STRUCTURE); -NODES[11940].Fix(IS_STRUCTURE); -NODES[11953].Fix(IS_STRUCTURE); -NODES[11960].Fix(IS_STRUCTURE); -NODES[11961].Fix(IS_STRUCTURE); -NODES[11967].Fix(IS_STRUCTURE); -NODES[11971].Fix(IS_STRUCTURE); -NODES[11985].Fix(IS_STRUCTURE); -NODES[11991].Fix(IS_STRUCTURE); -NODES[12003].Fix(IS_STRUCTURE); -NODES[12006].Fix(IS_STRUCTURE); -NODES[12013].Fix(IS_STRUCTURE); -NODES[12028].Fix(IS_STRUCTURE); -NODES[12030].Fix(IS_STRUCTURE); -NODES[12033].Fix(IS_STRUCTURE); -NODES[12042].Fix(IS_STRUCTURE); -NODES[12052].Fix(IS_STRUCTURE); -NODES[12067].Fix(IS_STRUCTURE); -NODES[12070].Fix(IS_STRUCTURE); -NODES[12072].Fix(IS_STRUCTURE); -NODES[12081].Fix(IS_STRUCTURE); -NODES[12084].Fix(IS_STRUCTURE); -NODES[12086].Fix(IS_STRUCTURE); -NODES[12094].Fix(IS_STRUCTURE); -NODES[12095].Fix(IS_STRUCTURE); -NODES[12096].Fix(IS_STRUCTURE); -NODES[12115].Fix(IS_STRUCTURE); -NODES[12117].Fix(IS_STRUCTURE); -NODES[12134].Fix(IS_STRUCTURE); -NODES[12135].Fix(IS_STRUCTURE); -NODES[12136].Fix(IS_STRUCTURE); -NODES[12137].Fix(IS_STRUCTURE); -NODES[12138].Fix(IS_STRUCTURE); -NODES[12139].Fix(IS_STRUCTURE); -NODES[12143].Fix(IS_STRUCTURE); -NODES[12151].Fix(IS_STRUCTURE); -NODES[12169].Fix(IS_STRUCTURE); -NODES[12170].Fix(IS_STRUCTURE); -NODES[12171].Fix(IS_STRUCTURE); -NODES[12172].Fix(IS_STRUCTURE); -NODES[12183].Fix(IS_STRUCTURE); -NODES[12192].Fix(IS_STRUCTURE); -NODES[12197].Fix(IS_STRUCTURE); -NODES[12211].Fix(IS_STRUCTURE); -NODES[12221].Fix(IS_STRUCTURE); -NODES[12225].Fix(IS_STRUCTURE); -NODES[12230].Fix(IS_STRUCTURE); -NODES[12235].Fix(IS_STRUCTURE); -NODES[12265].Fix(IS_STRUCTURE); -NODES[12266].Fix(IS_STRUCTURE); -NODES[12270].Fix(IS_STRUCTURE); -NODES[12294].Fix(IS_STRUCTURE); -NODES[12309].Fix(IS_STRUCTURE); -NODES[12314].Fix(IS_STRUCTURE); -NODES[12315].Fix(IS_STRUCTURE); -NODES[12316].Fix(IS_STRUCTURE); -NODES[12318].Fix(IS_STRUCTURE); -NODES[12328].Fix(IS_STRUCTURE); -NODES[12329].Fix(IS_STRUCTURE); -NODES[12337].Fix(IS_STRUCTURE); -NODES[12338].Fix(IS_STRUCTURE); -NODES[12339].Fix(IS_STRUCTURE); -NODES[12340].Fix(IS_STRUCTURE); -NODES[12342].Fix(IS_STRUCTURE); -NODES[12349].Fix(IS_STRUCTURE); -NODES[12355].Fix(IS_STRUCTURE); -NODES[12360].Fix(IS_STRUCTURE); -NODES[12361].Fix(IS_STRUCTURE); -NODES[12362].Fix(IS_STRUCTURE); -NODES[12363].Fix(IS_STRUCTURE); -NODES[12371].Fix(IS_STRUCTURE); -NODES[12375].Fix(IS_STRUCTURE); -NODES[12395].Fix(IS_STRUCTURE); -NODES[12396].Fix(IS_STRUCTURE); -NODES[12397].Fix(IS_STRUCTURE); -NODES[12399].Fix(IS_STRUCTURE); -NODES[12400].Fix(IS_STRUCTURE); -NODES[12431].Fix(IS_STRUCTURE); -NODES[12434].Fix(IS_STRUCTURE); -NODES[12439].Fix(IS_STRUCTURE); -NODES[12446].Fix(IS_STRUCTURE); -NODES[12449].Fix(IS_STRUCTURE); -NODES[12451].Fix(IS_STRUCTURE); -NODES[12452].Fix(IS_STRUCTURE); -NODES[12453].Fix(IS_STRUCTURE); -NODES[12456].Fix(IS_STRUCTURE); -NODES[12458].Fix(IS_STRUCTURE); -NODES[12460].Fix(IS_STRUCTURE); -NODES[12461].Fix(IS_STRUCTURE); -NODES[12470].Fix(IS_STRUCTURE); -NODES[12471].Fix(IS_STRUCTURE); -NODES[12487].Fix(IS_STRUCTURE); -NODES[12488].Fix(IS_STRUCTURE); -NODES[12489].Fix(IS_STRUCTURE); -NODES[12498].Fix(IS_STRUCTURE); -NODES[12508].Fix(IS_STRUCTURE); -NODES[12509].Fix(IS_STRUCTURE); -NODES[12523].Fix(IS_STRUCTURE); -NODES[12529].Fix(IS_STRUCTURE); -NODES[12536].Fix(IS_STRUCTURE); -NODES[12548].Fix(IS_STRUCTURE); -NODES[12558].Fix(IS_STRUCTURE); -NODES[12559].Fix(IS_STRUCTURE); -NODES[12564].Fix(IS_STRUCTURE); -NODES[12567].Fix(IS_STRUCTURE); -NODES[12574].Fix(IS_STRUCTURE); -NODES[12596].Fix(IS_STRUCTURE); -NODES[12597].Fix(IS_STRUCTURE); -NODES[12598].Fix(IS_STRUCTURE); -NODES[12599].Fix(IS_STRUCTURE); -NODES[12602].Fix(IS_STRUCTURE); -NODES[12604].Fix(IS_STRUCTURE); -NODES[12618].Fix(IS_STRUCTURE); -NODES[12621].Fix(IS_STRUCTURE); -NODES[12628].Fix(IS_STRUCTURE); -NODES[12630].Fix(IS_STRUCTURE); -NODES[12632].Fix(IS_STRUCTURE); -NODES[12638].Fix(IS_STRUCTURE); -NODES[12653].Fix(IS_STRUCTURE); -NODES[12663].Fix(IS_STRUCTURE); -NODES[12692].Fix(IS_STRUCTURE); -NODES[12693].Fix(IS_STRUCTURE); -NODES[12697].Fix(IS_STRUCTURE); -NODES[12701].Fix(IS_STRUCTURE); -NODES[12710].Fix(IS_STRUCTURE); -NODES[12716].Fix(IS_STRUCTURE); -NODES[12724].Fix(IS_STRUCTURE); -NODES[12725].Fix(IS_STRUCTURE); -NODES[12727].Fix(IS_STRUCTURE); -NODES[12743].Fix(IS_STRUCTURE); -NODES[12744].Fix(IS_STRUCTURE); -NODES[12760].Fix(IS_STRUCTURE); -NODES[12768].Fix(IS_STRUCTURE); -NODES[12774].Fix(IS_STRUCTURE); -NODES[12775].Fix(IS_STRUCTURE); -NODES[12796].Fix(IS_STRUCTURE); -NODES[12798].Fix(IS_STRUCTURE); -NODES[12810].Fix(IS_STRUCTURE); -NODES[12820].Fix(IS_STRUCTURE); -NODES[12821].Fix(IS_STRUCTURE); -NODES[12832].Fix(IS_STRUCTURE); -NODES[12834].Fix(IS_STRUCTURE); -NODES[12842].Fix(IS_STRUCTURE); -NODES[12852].Fix(IS_STRUCTURE); -NODES[12853].Fix(IS_STRUCTURE); -NODES[12854].Fix(IS_STRUCTURE); -NODES[12860].Fix(IS_STRUCTURE); -NODES[12861].Fix(IS_STRUCTURE); -NODES[12862].Fix(IS_STRUCTURE); -NODES[12863].Fix(IS_STRUCTURE); -NODES[12885].Fix(IS_STRUCTURE); -NODES[12912].Fix(IS_STRUCTURE); -NODES[12914].Fix(IS_STRUCTURE); -NODES[12915].Fix(IS_STRUCTURE); -NODES[12925].Fix(IS_STRUCTURE); -NODES[12941].Fix(IS_STRUCTURE); -NODES[12946].Fix(IS_STRUCTURE); -NODES[12951].Fix(IS_STRUCTURE); -NODES[12954].Fix(IS_STRUCTURE); -NODES[12964].Fix(IS_STRUCTURE); -NODES[12966].Fix(IS_STRUCTURE); -NODES[12968].Fix(IS_STRUCTURE); -NODES[12983].Fix(IS_STRUCTURE); -NODES[12991].Fix(IS_STRUCTURE); -NODES[12999].Fix(IS_STRUCTURE); -NODES[13018].Fix(IS_STRUCTURE); -NODES[13029].Fix(IS_STRUCTURE); -NODES[13033].Fix(IS_STRUCTURE); -NODES[13039].Fix(IS_STRUCTURE); -NODES[13042].Fix(IS_STRUCTURE); -NODES[13054].Fix(IS_STRUCTURE); -NODES[13056].Fix(IS_STRUCTURE); -NODES[13065].Fix(IS_STRUCTURE); -NODES[13073].Fix(IS_STRUCTURE); -NODES[13074].Fix(IS_STRUCTURE); -NODES[13086].Fix(IS_STRUCTURE); -NODES[13087].Fix(IS_STRUCTURE); -NODES[13099].Fix(IS_STRUCTURE); -NODES[13104].Fix(IS_STRUCTURE); -NODES[13105].Fix(IS_STRUCTURE); -NODES[13106].Fix(IS_STRUCTURE); -NODES[13107].Fix(IS_STRUCTURE); -NODES[13114].Fix(IS_STRUCTURE); -NODES[13115].Fix(IS_STRUCTURE); -NODES[13124].Fix(IS_STRUCTURE); -NODES[13128].Fix(IS_STRUCTURE); -NODES[13129].Fix(IS_STRUCTURE); -NODES[13130].Fix(IS_STRUCTURE); -NODES[13131].Fix(IS_STRUCTURE); -NODES[13132].Fix(IS_STRUCTURE); -NODES[13133].Fix(IS_STRUCTURE); -NODES[13151].Fix(IS_STRUCTURE); -NODES[13152].Fix(IS_STRUCTURE); -NODES[13155].Fix(IS_STRUCTURE); -NODES[13165].Fix(IS_STRUCTURE); -NODES[13168].Fix(IS_STRUCTURE); -NODES[13169].Fix(IS_STRUCTURE); -NODES[13191].Fix(IS_STRUCTURE); -NODES[13195].Fix(IS_STRUCTURE); -NODES[13201].Fix(IS_STRUCTURE); -NODES[13202].Fix(IS_STRUCTURE); -NODES[13208].Fix(IS_STRUCTURE); -NODES[13209].Fix(IS_STRUCTURE); -NODES[13216].Fix(IS_STRUCTURE); -NODES[13223].Fix(IS_STRUCTURE); -NODES[13235].Fix(IS_STRUCTURE); -NODES[13236].Fix(IS_STRUCTURE); -NODES[13242].Fix(IS_STRUCTURE); -NODES[13255].Fix(IS_STRUCTURE); -NODES[13260].Fix(IS_STRUCTURE); -NODES[13280].Fix(IS_STRUCTURE); -NODES[13283].Fix(IS_STRUCTURE); -NODES[13289].Fix(IS_STRUCTURE); -NODES[13290].Fix(IS_STRUCTURE); -NODES[13299].Fix(IS_STRUCTURE); -NODES[13312].Fix(IS_STRUCTURE); -NODES[13314].Fix(IS_STRUCTURE); -NODES[13326].Fix(IS_STRUCTURE); -NODES[13338].Fix(IS_STRUCTURE); -NODES[13344].Fix(IS_STRUCTURE); -NODES[13347].Fix(IS_STRUCTURE); -NODES[13348].Fix(IS_STRUCTURE); -NODES[13351].Fix(IS_STRUCTURE); -NODES[13360].Fix(IS_STRUCTURE); -NODES[13367].Fix(IS_STRUCTURE); -NODES[13372].Fix(IS_STRUCTURE); -NODES[13378].Fix(IS_STRUCTURE); -NODES[13388].Fix(IS_STRUCTURE); -NODES[13395].Fix(IS_STRUCTURE); -NODES[13417].Fix(IS_STRUCTURE); -NODES[13420].Fix(IS_STRUCTURE); -NODES[13423].Fix(IS_STRUCTURE); -NODES[13424].Fix(IS_STRUCTURE); -NODES[13425].Fix(IS_STRUCTURE); -NODES[13426].Fix(IS_STRUCTURE); -NODES[13436].Fix(IS_STRUCTURE); -NODES[13437].Fix(IS_STRUCTURE); -NODES[13439].Fix(IS_STRUCTURE); -NODES[13447].Fix(IS_STRUCTURE); -NODES[13452].Fix(IS_STRUCTURE); -NODES[13455].Fix(IS_STRUCTURE); -NODES[13466].Fix(IS_STRUCTURE); -NODES[13469].Fix(IS_STRUCTURE); -NODES[13486].Fix(IS_STRUCTURE); -NODES[13493].Fix(IS_STRUCTURE); -NODES[13497].Fix(IS_STRUCTURE); -NODES[13513].Fix(IS_STRUCTURE); -NODES[13524].Fix(IS_STRUCTURE); -NODES[13531].Fix(IS_STRUCTURE); -NODES[13537].Fix(IS_STRUCTURE); -NODES[13538].Fix(IS_STRUCTURE); -NODES[13540].Fix(IS_STRUCTURE); -NODES[13559].Fix(IS_STRUCTURE); -NODES[13562].Fix(IS_STRUCTURE); -NODES[13568].Fix(IS_STRUCTURE); -NODES[13580].Fix(IS_STRUCTURE); -NODES[13595].Fix(IS_STRUCTURE); -NODES[13601].Fix(IS_STRUCTURE); -NODES[13616].Fix(IS_STRUCTURE); -NODES[13618].Fix(IS_STRUCTURE); -NODES[13620].Fix(IS_STRUCTURE); -NODES[13635].Fix(IS_STRUCTURE); -NODES[13638].Fix(IS_STRUCTURE); -NODES[13650].Fix(IS_STRUCTURE); -NODES[13662].Fix(IS_STRUCTURE); -NODES[13678].Fix(IS_STRUCTURE); -NODES[13679].Fix(IS_STRUCTURE); -NODES[13690].Fix(IS_STRUCTURE); -NODES[13692].Fix(IS_STRUCTURE); -NODES[13696].Fix(IS_STRUCTURE); -NODES[13706].Fix(IS_STRUCTURE); -NODES[13712].Fix(IS_STRUCTURE); -NODES[13714].Fix(IS_STRUCTURE); -NODES[13723].Fix(IS_STRUCTURE); -NODES[13724].Fix(IS_STRUCTURE); -NODES[13725].Fix(IS_STRUCTURE); -NODES[13726].Fix(IS_STRUCTURE); -NODES[13727].Fix(IS_STRUCTURE); -NODES[13728].Fix(IS_STRUCTURE); -NODES[13751].Fix(IS_STRUCTURE); -NODES[13774].Fix(IS_STRUCTURE); -NODES[13796].Fix(IS_STRUCTURE); -NODES[13801].Fix(IS_STRUCTURE); -NODES[13802].Fix(IS_STRUCTURE); -NODES[13821].Fix(IS_STRUCTURE); -NODES[13824].Fix(IS_STRUCTURE); -NODES[13831].Fix(IS_STRUCTURE); -NODES[13833].Fix(IS_STRUCTURE); -NODES[13834].Fix(IS_STRUCTURE); -NODES[13838].Fix(IS_STRUCTURE); -NODES[13843].Fix(IS_STRUCTURE); -NODES[13852].Fix(IS_STRUCTURE); -NODES[13862].Fix(IS_STRUCTURE); -NODES[13865].Fix(IS_STRUCTURE); -NODES[13867].Fix(IS_STRUCTURE); -NODES[13889].Fix(IS_STRUCTURE); -NODES[13890].Fix(IS_STRUCTURE); -NODES[13893].Fix(IS_STRUCTURE); -NODES[13899].Fix(IS_STRUCTURE); -NODES[13904].Fix(IS_STRUCTURE); -NODES[13905].Fix(IS_STRUCTURE); -NODES[13908].Fix(IS_STRUCTURE); -NODES[13909].Fix(IS_STRUCTURE); -NODES[13910].Fix(IS_STRUCTURE); -NODES[13916].Fix(IS_STRUCTURE); -NODES[13918].Fix(IS_STRUCTURE); -NODES[13923].Fix(IS_STRUCTURE); -NODES[13931].Fix(IS_STRUCTURE); -NODES[13932].Fix(IS_STRUCTURE); -NODES[13935].Fix(IS_STRUCTURE); -NODES[13939].Fix(IS_STRUCTURE); -NODES[13945].Fix(IS_STRUCTURE); -NODES[13950].Fix(IS_STRUCTURE); -NODES[13956].Fix(IS_STRUCTURE); -NODES[13977].Fix(IS_STRUCTURE); -NODES[13979].Fix(IS_STRUCTURE); -NODES[13980].Fix(IS_STRUCTURE); -NODES[13987].Fix(IS_STRUCTURE); -NODES[13991].Fix(IS_STRUCTURE); -NODES[14006].Fix(IS_STRUCTURE); -NODES[14007].Fix(IS_STRUCTURE); -NODES[14016].Fix(IS_STRUCTURE); -NODES[14017].Fix(IS_STRUCTURE); -NODES[14034].Fix(IS_STRUCTURE); -NODES[14035].Fix(IS_STRUCTURE); -NODES[14036].Fix(IS_STRUCTURE); -NODES[14037].Fix(IS_STRUCTURE); -NODES[14038].Fix(IS_STRUCTURE); -NODES[14052].Fix(IS_STRUCTURE); -NODES[14054].Fix(IS_STRUCTURE); -NODES[14056].Fix(IS_STRUCTURE); -NODES[14064].Fix(IS_STRUCTURE); -NODES[14073].Fix(IS_STRUCTURE); -NODES[14074].Fix(IS_STRUCTURE); -NODES[14076].Fix(IS_STRUCTURE); -NODES[14091].Fix(IS_STRUCTURE); -NODES[14113].Fix(IS_STRUCTURE); -NODES[14116].Fix(IS_STRUCTURE); -NODES[14121].Fix(IS_STRUCTURE); -NODES[14124].Fix(IS_STRUCTURE); -NODES[14146].Fix(IS_STRUCTURE); -NODES[14167].Fix(IS_STRUCTURE); -NODES[14175].Fix(IS_STRUCTURE); -NODES[14179].Fix(IS_STRUCTURE); -NODES[14189].Fix(IS_STRUCTURE); -NODES[14197].Fix(IS_STRUCTURE); -NODES[14203].Fix(IS_STRUCTURE); -NODES[14212].Fix(IS_STRUCTURE); -NODES[14225].Fix(IS_STRUCTURE); -NODES[14228].Fix(IS_STRUCTURE); -NODES[14232].Fix(IS_STRUCTURE); -NODES[14235].Fix(IS_STRUCTURE); -NODES[14236].Fix(IS_STRUCTURE); -NODES[14239].Fix(IS_STRUCTURE); -NODES[14242].Fix(IS_STRUCTURE); -NODES[14281].Fix(IS_STRUCTURE); -NODES[14282].Fix(IS_STRUCTURE); -NODES[14284].Fix(IS_STRUCTURE); -NODES[14288].Fix(IS_STRUCTURE); -NODES[14295].Fix(IS_STRUCTURE); -NODES[14303].Fix(IS_STRUCTURE); -NODES[14306].Fix(IS_STRUCTURE); -NODES[14307].Fix(IS_STRUCTURE); -NODES[14308].Fix(IS_STRUCTURE); -NODES[14314].Fix(IS_STRUCTURE); -NODES[14317].Fix(IS_STRUCTURE); -NODES[14323].Fix(IS_STRUCTURE); -NODES[14326].Fix(IS_STRUCTURE); -NODES[14328].Fix(IS_STRUCTURE); -NODES[14344].Fix(IS_STRUCTURE); -NODES[14345].Fix(IS_STRUCTURE); -NODES[14346].Fix(IS_STRUCTURE); -NODES[14347].Fix(IS_STRUCTURE); -NODES[14376].Fix(IS_STRUCTURE); -NODES[14378].Fix(IS_STRUCTURE); -NODES[14385].Fix(IS_STRUCTURE); -NODES[14386].Fix(IS_STRUCTURE); -NODES[14399].Fix(IS_STRUCTURE); -NODES[14402].Fix(IS_STRUCTURE); -NODES[14404].Fix(IS_STRUCTURE); -NODES[14405].Fix(IS_STRUCTURE); -NODES[14410].Fix(IS_STRUCTURE); -NODES[14418].Fix(IS_STRUCTURE); -NODES[14431].Fix(IS_STRUCTURE); -NODES[14442].Fix(IS_STRUCTURE); -NODES[14449].Fix(IS_STRUCTURE); -NODES[14450].Fix(IS_STRUCTURE); -NODES[14459].Fix(IS_STRUCTURE); -NODES[14473].Fix(IS_STRUCTURE); -NODES[14519].Fix(IS_STRUCTURE); -NODES[14522].Fix(IS_STRUCTURE); -NODES[14524].Fix(IS_STRUCTURE); -NODES[14532].Fix(IS_STRUCTURE); -NODES[14536].Fix(IS_STRUCTURE); -NODES[14542].Fix(IS_STRUCTURE); -NODES[14551].Fix(IS_STRUCTURE); -NODES[14552].Fix(IS_STRUCTURE); -NODES[14556].Fix(IS_STRUCTURE); -NODES[14558].Fix(IS_STRUCTURE); -NODES[14563].Fix(IS_STRUCTURE); -NODES[14590].Fix(IS_STRUCTURE); -NODES[14605].Fix(IS_STRUCTURE); -NODES[14609].Fix(IS_STRUCTURE); -NODES[14619].Fix(IS_STRUCTURE); -NODES[14620].Fix(IS_STRUCTURE); -NODES[14644].Fix(IS_STRUCTURE); -NODES[14646].Fix(IS_STRUCTURE); -NODES[14660].Fix(IS_STRUCTURE); -NODES[14662].Fix(IS_STRUCTURE); -NODES[14663].Fix(IS_STRUCTURE); -NODES[14668].Fix(IS_STRUCTURE); -NODES[14669].Fix(IS_STRUCTURE); -NODES[14680].Fix(IS_STRUCTURE); -NODES[14681].Fix(IS_STRUCTURE); -NODES[14682].Fix(IS_STRUCTURE); -NODES[14683].Fix(IS_STRUCTURE); -NODES[14684].Fix(IS_STRUCTURE); -NODES[14689].Fix(IS_STRUCTURE); -NODES[14690].Fix(IS_STRUCTURE); -NODES[14705].Fix(IS_STRUCTURE); -NODES[14719].Fix(IS_STRUCTURE); -NODES[14723].Fix(IS_STRUCTURE); -NODES[14726].Fix(IS_STRUCTURE); -NODES[14731].Fix(IS_STRUCTURE); -NODES[14732].Fix(IS_STRUCTURE); -NODES[14734].Fix(IS_STRUCTURE); -NODES[14736].Fix(IS_STRUCTURE); -NODES[14737].Fix(IS_STRUCTURE); -NODES[14745].Fix(IS_STRUCTURE); -NODES[14750].Fix(IS_STRUCTURE); -NODES[14763].Fix(IS_STRUCTURE); -NODES[14765].Fix(IS_STRUCTURE); -NODES[14766].Fix(IS_STRUCTURE); -NODES[14768].Fix(IS_STRUCTURE); -NODES[14776].Fix(IS_STRUCTURE); -NODES[14782].Fix(IS_STRUCTURE); -NODES[14792].Fix(IS_STRUCTURE); -NODES[14794].Fix(IS_STRUCTURE); -NODES[14797].Fix(IS_STRUCTURE); -NODES[14800].Fix(IS_STRUCTURE); -NODES[14813].Fix(IS_STRUCTURE); -NODES[14817].Fix(IS_STRUCTURE); -NODES[14823].Fix(IS_STRUCTURE); -NODES[14833].Fix(IS_STRUCTURE); -NODES[14838].Fix(IS_STRUCTURE); -NODES[14841].Fix(IS_STRUCTURE); -NODES[14852].Fix(IS_STRUCTURE); -NODES[14884].Fix(IS_STRUCTURE); -NODES[14889].Fix(IS_STRUCTURE); -NODES[14893].Fix(IS_STRUCTURE); -NODES[14895].Fix(IS_STRUCTURE); -NODES[14899].Fix(IS_STRUCTURE); -NODES[14906].Fix(IS_STRUCTURE); -NODES[14911].Fix(IS_STRUCTURE); -NODES[14912].Fix(IS_STRUCTURE); -NODES[14913].Fix(IS_STRUCTURE); -NODES[14922].Fix(IS_STRUCTURE); -NODES[14928].Fix(IS_STRUCTURE); -NODES[14964].Fix(IS_STRUCTURE); -NODES[14977].Fix(IS_STRUCTURE); -NODES[14984].Fix(IS_STRUCTURE); -NODES[14988].Fix(IS_STRUCTURE); -NODES[14989].Fix(IS_STRUCTURE); -NODES[14990].Fix(IS_STRUCTURE); -NODES[14991].Fix(IS_STRUCTURE); -NODES[14993].Fix(IS_STRUCTURE); -NODES[14995].Fix(IS_STRUCTURE); -NODES[14999].Fix(IS_STRUCTURE); -NODES[15004].Fix(IS_STRUCTURE); -NODES[15005].Fix(IS_STRUCTURE); -NODES[15027].Fix(IS_STRUCTURE); -NODES[15028].Fix(IS_STRUCTURE); -NODES[15029].Fix(IS_STRUCTURE); -NODES[15032].Fix(IS_STRUCTURE); -NODES[15040].Fix(IS_STRUCTURE); -NODES[15059].Fix(IS_STRUCTURE); -NODES[15065].Fix(IS_STRUCTURE); -NODES[15068].Fix(IS_STRUCTURE); -NODES[15078].Fix(IS_STRUCTURE); -NODES[15084].Fix(IS_STRUCTURE); -NODES[15088].Fix(IS_STRUCTURE); -NODES[15102].Fix(IS_STRUCTURE); -NODES[15103].Fix(IS_STRUCTURE); -NODES[15114].Fix(IS_STRUCTURE); -NODES[15123].Fix(IS_STRUCTURE); -NODES[15133].Fix(IS_STRUCTURE); -NODES[15142].Fix(IS_STRUCTURE); -NODES[15148].Fix(IS_STRUCTURE); -NODES[15149].Fix(IS_STRUCTURE); -NODES[15151].Fix(IS_STRUCTURE); -NODES[15170].Fix(IS_STRUCTURE); -NODES[15176].Fix(IS_STRUCTURE); -NODES[15179].Fix(IS_STRUCTURE); -NODES[15185].Fix(IS_STRUCTURE); -NODES[15190].Fix(IS_STRUCTURE); -NODES[15194].Fix(IS_STRUCTURE); -NODES[15195].Fix(IS_STRUCTURE); -NODES[15198].Fix(IS_STRUCTURE); -NODES[15206].Fix(IS_STRUCTURE); -NODES[15207].Fix(IS_STRUCTURE); -NODES[15218].Fix(IS_STRUCTURE); -NODES[15227].Fix(IS_STRUCTURE); -NODES[15233].Fix(IS_STRUCTURE); -NODES[15253].Fix(IS_STRUCTURE); -NODES[15262].Fix(IS_STRUCTURE); -NODES[15264].Fix(IS_STRUCTURE); -NODES[15265].Fix(IS_STRUCTURE); -NODES[15266].Fix(IS_STRUCTURE); -NODES[15270].Fix(IS_STRUCTURE); -NODES[15273].Fix(IS_STRUCTURE); -NODES[15280].Fix(IS_STRUCTURE); -NODES[15283].Fix(IS_STRUCTURE); -NODES[15285].Fix(IS_STRUCTURE); -NODES[15288].Fix(IS_STRUCTURE); -NODES[15301].Fix(IS_STRUCTURE); -NODES[15309].Fix(IS_STRUCTURE); -NODES[15310].Fix(IS_STRUCTURE); -NODES[15311].Fix(IS_STRUCTURE); -NODES[15330].Fix(IS_STRUCTURE); -NODES[15335].Fix(IS_STRUCTURE); -NODES[15337].Fix(IS_STRUCTURE); -NODES[15342].Fix(IS_STRUCTURE); -NODES[15349].Fix(IS_STRUCTURE); -NODES[15355].Fix(IS_STRUCTURE); -NODES[15356].Fix(IS_STRUCTURE); -NODES[15361].Fix(IS_STRUCTURE); -NODES[15372].Fix(IS_STRUCTURE); -NODES[15375].Fix(IS_STRUCTURE); -NODES[15397].Fix(IS_STRUCTURE); -NODES[15406].Fix(IS_STRUCTURE); -NODES[15408].Fix(IS_STRUCTURE); -NODES[15409].Fix(IS_STRUCTURE); -NODES[15414].Fix(IS_STRUCTURE); -NODES[15418].Fix(IS_STRUCTURE); -NODES[15430].Fix(IS_STRUCTURE); -NODES[15440].Fix(IS_STRUCTURE); -NODES[15447].Fix(IS_STRUCTURE); -NODES[15448].Fix(IS_STRUCTURE); -NODES[15451].Fix(IS_STRUCTURE); -NODES[15460].Fix(IS_STRUCTURE); -NODES[15469].Fix(IS_STRUCTURE); -NODES[15471].Fix(IS_STRUCTURE); -NODES[15472].Fix(IS_STRUCTURE); -NODES[15481].Fix(IS_STRUCTURE); -NODES[15482].Fix(IS_STRUCTURE); -NODES[15501].Fix(IS_STRUCTURE); -NODES[15504].Fix(IS_STRUCTURE); -NODES[15512].Fix(IS_STRUCTURE); -NODES[15518].Fix(IS_STRUCTURE); -NODES[15521].Fix(IS_STRUCTURE); -NODES[15529].Fix(IS_STRUCTURE); -NODES[15540].Fix(IS_STRUCTURE); -NODES[15542].Fix(IS_STRUCTURE); -NODES[15544].Fix(IS_STRUCTURE); -NODES[15546].Fix(IS_STRUCTURE); -NODES[15551].Fix(IS_STRUCTURE); -NODES[15552].Fix(IS_STRUCTURE); -NODES[15554].Fix(IS_STRUCTURE); -NODES[15560].Fix(IS_STRUCTURE); -NODES[15561].Fix(IS_STRUCTURE); -NODES[15583].Fix(IS_STRUCTURE); -NODES[15595].Fix(IS_STRUCTURE); -NODES[15597].Fix(IS_STRUCTURE); -NODES[15601].Fix(IS_STRUCTURE); -NODES[15602].Fix(IS_STRUCTURE); -NODES[15607].Fix(IS_STRUCTURE); -NODES[15608].Fix(IS_STRUCTURE); -NODES[15613].Fix(IS_STRUCTURE); -NODES[15618].Fix(IS_STRUCTURE); -NODES[15619].Fix(IS_STRUCTURE); -NODES[15620].Fix(IS_STRUCTURE); -NODES[15621].Fix(IS_STRUCTURE); -NODES[15623].Fix(IS_STRUCTURE); -NODES[15646].Fix(IS_STRUCTURE); -NODES[15659].Fix(IS_STRUCTURE); -NODES[15660].Fix(IS_STRUCTURE); -NODES[15661].Fix(IS_STRUCTURE); -NODES[15662].Fix(IS_STRUCTURE); -NODES[15663].Fix(IS_STRUCTURE); -NODES[15681].Fix(IS_STRUCTURE); -NODES[15698].Fix(IS_STRUCTURE); -NODES[15708].Fix(IS_STRUCTURE); -NODES[15711].Fix(IS_STRUCTURE); -NODES[15723].Fix(IS_STRUCTURE); -NODES[15732].Fix(IS_STRUCTURE); -NODES[15734].Fix(IS_STRUCTURE); -NODES[15743].Fix(IS_STRUCTURE); -NODES[15750].Fix(IS_STRUCTURE); -NODES[15752].Fix(IS_STRUCTURE); -NODES[15764].Fix(IS_STRUCTURE); -NODES[15769].Fix(IS_STRUCTURE); -NODES[15773].Fix(IS_STRUCTURE); -NODES[15777].Fix(IS_STRUCTURE); -NODES[15779].Fix(IS_STRUCTURE); -NODES[15781].Fix(IS_STRUCTURE); -NODES[15785].Fix(IS_STRUCTURE); -NODES[15799].Fix(IS_STRUCTURE); -NODES[15817].Fix(IS_STRUCTURE); -NODES[15819].Fix(IS_STRUCTURE); -NODES[15820].Fix(IS_STRUCTURE); -NODES[15832].Fix(IS_STRUCTURE); -NODES[15844].Fix(IS_STRUCTURE); -NODES[15857].Fix(IS_STRUCTURE); -NODES[15861].Fix(IS_STRUCTURE); -NODES[15863].Fix(IS_STRUCTURE); -NODES[15869].Fix(IS_STRUCTURE); -NODES[15883].Fix(IS_STRUCTURE); -NODES[15890].Fix(IS_STRUCTURE); -NODES[15894].Fix(IS_STRUCTURE); -NODES[15895].Fix(IS_STRUCTURE); -NODES[15896].Fix(IS_STRUCTURE); -NODES[15901].Fix(IS_STRUCTURE); -NODES[15902].Fix(IS_STRUCTURE); -NODES[15912].Fix(IS_STRUCTURE); -NODES[15917].Fix(IS_STRUCTURE); -NODES[15920].Fix(IS_STRUCTURE); -NODES[15923].Fix(IS_STRUCTURE); -NODES[15924].Fix(IS_STRUCTURE); -NODES[15926].Fix(IS_STRUCTURE); -NODES[15932].Fix(IS_STRUCTURE); -NODES[15934].Fix(IS_STRUCTURE); -NODES[15937].Fix(IS_STRUCTURE); -NODES[15938].Fix(IS_STRUCTURE); -NODES[15940].Fix(IS_STRUCTURE); -NODES[15941].Fix(IS_STRUCTURE); -NODES[15966].Fix(IS_STRUCTURE); -NODES[15967].Fix(IS_STRUCTURE); -NODES[15972].Fix(IS_STRUCTURE); -NODES[15980].Fix(IS_STRUCTURE); -NODES[15982].Fix(IS_STRUCTURE); -NODES[15994].Fix(IS_STRUCTURE); -NODES[15995].Fix(IS_STRUCTURE); -NODES[16026].Fix(IS_STRUCTURE); -NODES[16027].Fix(IS_STRUCTURE); -NODES[16028].Fix(IS_STRUCTURE); -NODES[16031].Fix(IS_STRUCTURE); -NODES[16036].Fix(IS_STRUCTURE); -NODES[16037].Fix(IS_STRUCTURE); -NODES[16039].Fix(IS_STRUCTURE); -NODES[16042].Fix(IS_STRUCTURE); -NODES[16047].Fix(IS_STRUCTURE); -NODES[16048].Fix(IS_STRUCTURE); -NODES[16061].Fix(IS_STRUCTURE); -NODES[16062].Fix(IS_STRUCTURE); -NODES[16076].Fix(IS_STRUCTURE); -NODES[16080].Fix(IS_STRUCTURE); -NODES[16083].Fix(IS_STRUCTURE); -NODES[16090].Fix(IS_STRUCTURE); -NODES[16091].Fix(IS_STRUCTURE); -NODES[16111].Fix(IS_STRUCTURE); -NODES[16114].Fix(IS_STRUCTURE); -NODES[16118].Fix(IS_STRUCTURE); -NODES[16127].Fix(IS_STRUCTURE); -NODES[16129].Fix(IS_STRUCTURE); -NODES[16137].Fix(IS_STRUCTURE); -NODES[16144].Fix(IS_STRUCTURE); -NODES[16153].Fix(IS_STRUCTURE); -NODES[16156].Fix(IS_STRUCTURE); -NODES[16161].Fix(IS_STRUCTURE); -NODES[16163].Fix(IS_STRUCTURE); -NODES[16165].Fix(IS_STRUCTURE); -NODES[16168].Fix(IS_STRUCTURE); -NODES[16169].Fix(IS_STRUCTURE); -NODES[16181].Fix(IS_STRUCTURE); -NODES[16196].Fix(IS_STRUCTURE); -NODES[16204].Fix(IS_STRUCTURE); -NODES[16210].Fix(IS_STRUCTURE); -NODES[16216].Fix(IS_STRUCTURE); -NODES[16220].Fix(IS_STRUCTURE); -NODES[16223].Fix(IS_STRUCTURE); -NODES[16224].Fix(IS_STRUCTURE); -NODES[16230].Fix(IS_STRUCTURE); -NODES[16239].Fix(IS_STRUCTURE); -NODES[16244].Fix(IS_STRUCTURE); -NODES[16249].Fix(IS_STRUCTURE); -NODES[16261].Fix(IS_STRUCTURE); -NODES[16262].Fix(IS_STRUCTURE); -NODES[16267].Fix(IS_STRUCTURE); -NODES[16269].Fix(IS_STRUCTURE); -NODES[16291].Fix(IS_STRUCTURE); -NODES[16292].Fix(IS_STRUCTURE); -NODES[16293].Fix(IS_STRUCTURE); -NODES[16296].Fix(IS_STRUCTURE); -NODES[16300].Fix(IS_STRUCTURE); -NODES[16302].Fix(IS_STRUCTURE); -NODES[16310].Fix(IS_STRUCTURE); -NODES[16321].Fix(IS_STRUCTURE); -NODES[16326].Fix(IS_STRUCTURE); -NODES[16329].Fix(IS_STRUCTURE); -NODES[16334].Fix(IS_STRUCTURE); -NODES[16343].Fix(IS_STRUCTURE); -NODES[16344].Fix(IS_STRUCTURE); -NODES[16346].Fix(IS_STRUCTURE); -NODES[16352].Fix(IS_STRUCTURE); -NODES[16353].Fix(IS_STRUCTURE); -NODES[16357].Fix(IS_STRUCTURE); -NODES[16359].Fix(IS_STRUCTURE); -NODES[16376].Fix(IS_STRUCTURE); -NODES[16387].Fix(IS_STRUCTURE); -NODES[16391].Fix(IS_STRUCTURE); -NODES[16392].Fix(IS_STRUCTURE); -NODES[16393].Fix(IS_STRUCTURE); -NODES[16398].Fix(IS_STRUCTURE); -NODES[16406].Fix(IS_STRUCTURE); -NODES[16411].Fix(IS_STRUCTURE); -NODES[16412].Fix(IS_STRUCTURE); -NODES[16413].Fix(IS_STRUCTURE); -NODES[16420].Fix(IS_STRUCTURE); -NODES[16439].Fix(IS_STRUCTURE); -NODES[16442].Fix(IS_STRUCTURE); -NODES[16448].Fix(IS_STRUCTURE); -NODES[16451].Fix(IS_STRUCTURE); -NODES[16460].Fix(IS_STRUCTURE); -NODES[16461].Fix(IS_STRUCTURE); -NODES[16462].Fix(IS_STRUCTURE); -NODES[16478].Fix(IS_STRUCTURE); -NODES[16480].Fix(IS_STRUCTURE); -NODES[16483].Fix(IS_STRUCTURE); -NODES[16494].Fix(IS_STRUCTURE); -NODES[16495].Fix(IS_STRUCTURE); -NODES[16497].Fix(IS_STRUCTURE); -NODES[16501].Fix(IS_STRUCTURE); -NODES[16503].Fix(IS_STRUCTURE); -NODES[16516].Fix(IS_STRUCTURE); -NODES[16526].Fix(IS_STRUCTURE); -NODES[16529].Fix(IS_STRUCTURE); -NODES[16531].Fix(IS_STRUCTURE); -NODES[16532].Fix(IS_STRUCTURE); -NODES[16534].Fix(IS_STRUCTURE); -NODES[16536].Fix(IS_STRUCTURE); -NODES[16539].Fix(IS_STRUCTURE); -NODES[16540].Fix(IS_STRUCTURE); -NODES[16550].Fix(IS_STRUCTURE); -NODES[16553].Fix(IS_STRUCTURE); -NODES[16556].Fix(IS_STRUCTURE); -NODES[16566].Fix(IS_STRUCTURE); -NODES[16569].Fix(IS_STRUCTURE); -NODES[16577].Fix(IS_STRUCTURE); -NODES[16585].Fix(IS_STRUCTURE); -NODES[16586].Fix(IS_STRUCTURE); -NODES[16588].Fix(IS_STRUCTURE); -NODES[16621].Fix(IS_STRUCTURE); -NODES[16628].Fix(IS_STRUCTURE); -NODES[16630].Fix(IS_STRUCTURE); -NODES[16631].Fix(IS_STRUCTURE); -NODES[16632].Fix(IS_STRUCTURE); -NODES[16639].Fix(IS_STRUCTURE); -NODES[16645].Fix(IS_STRUCTURE); -NODES[16647].Fix(IS_STRUCTURE); -NODES[16651].Fix(IS_STRUCTURE); -NODES[16653].Fix(IS_STRUCTURE); -NODES[16662].Fix(IS_STRUCTURE); -NODES[16663].Fix(IS_STRUCTURE); -NODES[16665].Fix(IS_STRUCTURE); -NODES[16679].Fix(IS_STRUCTURE); -NODES[16681].Fix(IS_STRUCTURE); -NODES[16682].Fix(IS_STRUCTURE); -NODES[16688].Fix(IS_STRUCTURE); -NODES[16701].Fix(IS_STRUCTURE); -NODES[16711].Fix(IS_STRUCTURE); -NODES[16716].Fix(IS_STRUCTURE); -NODES[16721].Fix(IS_STRUCTURE); -NODES[16730].Fix(IS_STRUCTURE); -NODES[16733].Fix(IS_STRUCTURE); -NODES[16736].Fix(IS_STRUCTURE); -NODES[16737].Fix(IS_STRUCTURE); -NODES[16742].Fix(IS_STRUCTURE); -NODES[16749].Fix(IS_STRUCTURE); -NODES[16754].Fix(IS_STRUCTURE); -NODES[16762].Fix(IS_STRUCTURE); -NODES[16765].Fix(IS_STRUCTURE); -NODES[16766].Fix(IS_STRUCTURE); -NODES[16774].Fix(IS_STRUCTURE); -NODES[16775].Fix(IS_STRUCTURE); -NODES[16791].Fix(IS_STRUCTURE); -NODES[16797].Fix(IS_STRUCTURE); -NODES[16813].Fix(IS_STRUCTURE); -NODES[16821].Fix(IS_STRUCTURE); -NODES[16823].Fix(IS_STRUCTURE); -NODES[16824].Fix(IS_STRUCTURE); -NODES[16828].Fix(IS_STRUCTURE); -NODES[16829].Fix(IS_STRUCTURE); -NODES[16837].Fix(IS_STRUCTURE); -NODES[16841].Fix(IS_STRUCTURE); -NODES[16844].Fix(IS_STRUCTURE); -NODES[16847].Fix(IS_STRUCTURE); -NODES[16850].Fix(IS_STRUCTURE); -NODES[16851].Fix(IS_STRUCTURE); -NODES[16858].Fix(IS_STRUCTURE); -NODES[16867].Fix(IS_STRUCTURE); -NODES[16874].Fix(IS_STRUCTURE); -NODES[16877].Fix(IS_STRUCTURE); -NODES[16878].Fix(IS_STRUCTURE); -NODES[16879].Fix(IS_STRUCTURE); -NODES[16881].Fix(IS_STRUCTURE); -NODES[16884].Fix(IS_STRUCTURE); -NODES[16887].Fix(IS_STRUCTURE); -NODES[16899].Fix(IS_STRUCTURE); -NODES[16906].Fix(IS_STRUCTURE); -NODES[16907].Fix(IS_STRUCTURE); -NODES[16908].Fix(IS_STRUCTURE); -NODES[16939].Fix(IS_STRUCTURE); -NODES[16940].Fix(IS_STRUCTURE); -NODES[16952].Fix(IS_STRUCTURE); -NODES[16953].Fix(IS_STRUCTURE); -NODES[16955].Fix(IS_STRUCTURE); -NODES[16962].Fix(IS_STRUCTURE); -NODES[16966].Fix(IS_STRUCTURE); -NODES[16970].Fix(IS_STRUCTURE); -NODES[16974].Fix(IS_STRUCTURE); -NODES[16986].Fix(IS_STRUCTURE); -NODES[16990].Fix(IS_STRUCTURE); -NODES[16993].Fix(IS_STRUCTURE); -NODES[16995].Fix(IS_STRUCTURE); -NODES[16996].Fix(IS_STRUCTURE); -NODES[16997].Fix(IS_STRUCTURE); -NODES[17000].Fix(IS_STRUCTURE); -NODES[17009].Fix(IS_STRUCTURE); -NODES[17010].Fix(IS_STRUCTURE); -NODES[17015].Fix(IS_STRUCTURE); -NODES[17016].Fix(IS_STRUCTURE); -NODES[17029].Fix(IS_STRUCTURE); -NODES[17030].Fix(IS_STRUCTURE); -NODES[17034].Fix(IS_STRUCTURE); -NODES[17039].Fix(IS_STRUCTURE); -NODES[17042].Fix(IS_STRUCTURE); -NODES[17043].Fix(IS_STRUCTURE); -NODES[17047].Fix(IS_STRUCTURE); -NODES[17055].Fix(IS_STRUCTURE); -NODES[17062].Fix(IS_STRUCTURE); -NODES[17064].Fix(IS_STRUCTURE); -NODES[17072].Fix(IS_STRUCTURE); -NODES[17077].Fix(IS_STRUCTURE); -NODES[17081].Fix(IS_STRUCTURE); -NODES[17092].Fix(IS_STRUCTURE); -NODES[17093].Fix(IS_STRUCTURE); -NODES[17104].Fix(IS_STRUCTURE); -NODES[17106].Fix(IS_STRUCTURE); -NODES[17110].Fix(IS_STRUCTURE); -NODES[17111].Fix(IS_STRUCTURE); -NODES[17112].Fix(IS_STRUCTURE); -NODES[17115].Fix(IS_STRUCTURE); -NODES[17124].Fix(IS_STRUCTURE); -NODES[17125].Fix(IS_STRUCTURE); -NODES[17133].Fix(IS_STRUCTURE); -NODES[17142].Fix(IS_STRUCTURE); -NODES[17145].Fix(IS_STRUCTURE); -NODES[17152].Fix(IS_STRUCTURE); -NODES[17153].Fix(IS_STRUCTURE); -NODES[17158].Fix(IS_STRUCTURE); -NODES[17161].Fix(IS_STRUCTURE); -NODES[17167].Fix(IS_STRUCTURE); -NODES[17169].Fix(IS_STRUCTURE); -NODES[17190].Fix(IS_STRUCTURE); -NODES[17191].Fix(IS_STRUCTURE); -NODES[17193].Fix(IS_STRUCTURE); -NODES[17194].Fix(IS_STRUCTURE); -NODES[17196].Fix(IS_STRUCTURE); -NODES[17197].Fix(IS_STRUCTURE); -NODES[17200].Fix(IS_STRUCTURE); -NODES[17202].Fix(IS_STRUCTURE); -NODES[17209].Fix(IS_STRUCTURE); -NODES[17211].Fix(IS_STRUCTURE); -NODES[17233].Fix(IS_STRUCTURE); -NODES[17235].Fix(IS_STRUCTURE); -NODES[17238].Fix(IS_STRUCTURE); -NODES[17240].Fix(IS_STRUCTURE); -NODES[17245].Fix(IS_STRUCTURE); -NODES[17262].Fix(IS_STRUCTURE); -NODES[17266].Fix(IS_STRUCTURE); -NODES[17270].Fix(IS_STRUCTURE); -NODES[17272].Fix(IS_STRUCTURE); -NODES[17276].Fix(IS_STRUCTURE); -NODES[17278].Fix(IS_STRUCTURE); -NODES[17279].Fix(IS_STRUCTURE); -NODES[17284].Fix(IS_STRUCTURE); -NODES[17287].Fix(IS_STRUCTURE); -NODES[17295].Fix(IS_STRUCTURE); -NODES[17299].Fix(IS_STRUCTURE); -NODES[17300].Fix(IS_STRUCTURE); -NODES[17302].Fix(IS_STRUCTURE); -NODES[17327].Fix(IS_STRUCTURE); -NODES[17330].Fix(IS_STRUCTURE); -NODES[17347].Fix(IS_STRUCTURE); -NODES[17357].Fix(IS_STRUCTURE); -NODES[17359].Fix(IS_STRUCTURE); -NODES[17361].Fix(IS_STRUCTURE); -NODES[17365].Fix(IS_STRUCTURE); -NODES[17366].Fix(IS_STRUCTURE); -NODES[17368].Fix(IS_STRUCTURE); -NODES[17370].Fix(IS_STRUCTURE); -NODES[17371].Fix(IS_STRUCTURE); -NODES[17376].Fix(IS_STRUCTURE); -NODES[17382].Fix(IS_STRUCTURE); -NODES[17386].Fix(IS_STRUCTURE); -NODES[17390].Fix(IS_STRUCTURE); -NODES[17392].Fix(IS_STRUCTURE); -NODES[17395].Fix(IS_STRUCTURE); -NODES[17400].Fix(IS_STRUCTURE); -NODES[17403].Fix(IS_STRUCTURE); -NODES[17404].Fix(IS_STRUCTURE); -NODES[17411].Fix(IS_STRUCTURE); -NODES[17413].Fix(IS_STRUCTURE); -NODES[17418].Fix(IS_STRUCTURE); -NODES[17422].Fix(IS_STRUCTURE); -NODES[17427].Fix(IS_STRUCTURE); -NODES[17436].Fix(IS_STRUCTURE); -NODES[17440].Fix(IS_STRUCTURE); -NODES[17442].Fix(IS_STRUCTURE); -NODES[17453].Fix(IS_STRUCTURE); -NODES[17455].Fix(IS_STRUCTURE); -NODES[17459].Fix(IS_STRUCTURE); -NODES[17465].Fix(IS_STRUCTURE); -NODES[17466].Fix(IS_STRUCTURE); -NODES[17472].Fix(IS_STRUCTURE); -NODES[17479].Fix(IS_STRUCTURE); -NODES[17482].Fix(IS_STRUCTURE); -NODES[17486].Fix(IS_STRUCTURE); -NODES[17487].Fix(IS_STRUCTURE); -NODES[17496].Fix(IS_STRUCTURE); -NODES[17498].Fix(IS_STRUCTURE); -NODES[17502].Fix(IS_STRUCTURE); -NODES[17508].Fix(IS_STRUCTURE); -NODES[17516].Fix(IS_STRUCTURE); -NODES[17518].Fix(IS_STRUCTURE); -NODES[17519].Fix(IS_STRUCTURE); -NODES[17522].Fix(IS_STRUCTURE); -NODES[17525].Fix(IS_STRUCTURE); -NODES[17526].Fix(IS_STRUCTURE); -NODES[17531].Fix(IS_STRUCTURE); -NODES[17538].Fix(IS_STRUCTURE); -NODES[17541].Fix(IS_STRUCTURE); -NODES[17559].Fix(IS_STRUCTURE); -NODES[17561].Fix(IS_STRUCTURE); -NODES[17562].Fix(IS_STRUCTURE); -NODES[17566].Fix(IS_STRUCTURE); -NODES[17567].Fix(IS_STRUCTURE); -NODES[17577].Fix(IS_STRUCTURE); -NODES[17579].Fix(IS_STRUCTURE); -NODES[17583].Fix(IS_STRUCTURE); -NODES[17584].Fix(IS_STRUCTURE); -NODES[17585].Fix(IS_STRUCTURE); -NODES[17606].Fix(IS_STRUCTURE); -NODES[17611].Fix(IS_STRUCTURE); -NODES[17617].Fix(IS_STRUCTURE); -NODES[17621].Fix(IS_STRUCTURE); -NODES[17628].Fix(IS_STRUCTURE); -NODES[17630].Fix(IS_STRUCTURE); -NODES[17632].Fix(IS_STRUCTURE); -NODES[17639].Fix(IS_STRUCTURE); -NODES[17642].Fix(IS_STRUCTURE); -NODES[17651].Fix(IS_STRUCTURE); -NODES[17654].Fix(IS_STRUCTURE); -NODES[17655].Fix(IS_STRUCTURE); -NODES[17661].Fix(IS_STRUCTURE); -NODES[17665].Fix(IS_STRUCTURE); -NODES[17668].Fix(IS_STRUCTURE); -NODES[17669].Fix(IS_STRUCTURE); -NODES[17675].Fix(IS_STRUCTURE); -NODES[17680].Fix(IS_STRUCTURE); -NODES[17681].Fix(IS_STRUCTURE); -NODES[17684].Fix(IS_STRUCTURE); -NODES[17685].Fix(IS_STRUCTURE); -NODES[17686].Fix(IS_STRUCTURE); -NODES[17690].Fix(IS_STRUCTURE); -NODES[17695].Fix(IS_STRUCTURE); -NODES[17696].Fix(IS_STRUCTURE); -NODES[17698].Fix(IS_STRUCTURE); -NODES[17713].Fix(IS_STRUCTURE); -NODES[17717].Fix(IS_STRUCTURE); -NODES[17718].Fix(IS_STRUCTURE); -NODES[17723].Fix(IS_STRUCTURE); -NODES[17726].Fix(IS_STRUCTURE); -NODES[17729].Fix(IS_STRUCTURE); -NODES[17735].Fix(IS_STRUCTURE); -NODES[17736].Fix(IS_STRUCTURE); -NODES[17742].Fix(IS_STRUCTURE); -NODES[17745].Fix(IS_STRUCTURE); -NODES[17757].Fix(IS_STRUCTURE); -NODES[17761].Fix(IS_STRUCTURE); -NODES[17762].Fix(IS_STRUCTURE); -NODES[17763].Fix(IS_STRUCTURE); -NODES[17765].Fix(IS_STRUCTURE); -NODES[17766].Fix(IS_STRUCTURE); -NODES[17771].Fix(IS_STRUCTURE); -NODES[17774].Fix(IS_STRUCTURE); -NODES[17776].Fix(IS_STRUCTURE); -NODES[17781].Fix(IS_STRUCTURE); -NODES[17797].Fix(IS_STRUCTURE); -NODES[17807].Fix(IS_STRUCTURE); -NODES[17816].Fix(IS_STRUCTURE); -NODES[17817].Fix(IS_STRUCTURE); -NODES[17819].Fix(IS_STRUCTURE); -NODES[17820].Fix(IS_STRUCTURE); -NODES[17829].Fix(IS_STRUCTURE); -NODES[17831].Fix(IS_STRUCTURE); -NODES[17837].Fix(IS_STRUCTURE); -NODES[17846].Fix(IS_STRUCTURE); -NODES[17847].Fix(IS_STRUCTURE); -NODES[17849].Fix(IS_STRUCTURE); -NODES[17861].Fix(IS_STRUCTURE); -NODES[17862].Fix(IS_STRUCTURE); -NODES[17864].Fix(IS_STRUCTURE); -NODES[17866].Fix(IS_STRUCTURE); -NODES[17869].Fix(IS_STRUCTURE); -NODES[17870].Fix(IS_STRUCTURE); -NODES[17871].Fix(IS_STRUCTURE); -NODES[17878].Fix(IS_STRUCTURE); -NODES[17880].Fix(IS_STRUCTURE); -NODES[17881].Fix(IS_STRUCTURE); -NODES[17883].Fix(IS_STRUCTURE); -NODES[17886].Fix(IS_STRUCTURE); -NODES[17888].Fix(IS_STRUCTURE); -NODES[17893].Fix(IS_STRUCTURE); -NODES[17898].Fix(IS_STRUCTURE); -NODES[17906].Fix(IS_STRUCTURE); -NODES[17907].Fix(IS_STRUCTURE); -NODES[17910].Fix(IS_STRUCTURE); -NODES[17914].Fix(IS_STRUCTURE); -NODES[17915].Fix(IS_STRUCTURE); -NODES[17916].Fix(IS_STRUCTURE); -NODES[17918].Fix(IS_STRUCTURE); -NODES[17923].Fix(IS_STRUCTURE); -NODES[17926].Fix(IS_STRUCTURE); -NODES[17927].Fix(IS_STRUCTURE); -NODES[17928].Fix(IS_STRUCTURE); -NODES[17937].Fix(IS_STRUCTURE); -NODES[17941].Fix(IS_STRUCTURE); -NODES[17942].Fix(IS_STRUCTURE); -NODES[17953].Fix(IS_STRUCTURE); -NODES[17954].Fix(IS_STRUCTURE); -NODES[17962].Fix(IS_STRUCTURE); -NODES[17968].Fix(IS_STRUCTURE); -NODES[17973].Fix(IS_STRUCTURE); -NODES[17976].Fix(IS_STRUCTURE); -NODES[17984].Fix(IS_STRUCTURE); -NODES[17985].Fix(IS_STRUCTURE); -NODES[17988].Fix(IS_STRUCTURE); -NODES[17989].Fix(IS_STRUCTURE); -NODES[17990].Fix(IS_STRUCTURE); -NODES[17991].Fix(IS_STRUCTURE); -NODES[17997].Fix(IS_STRUCTURE); -NODES[18000].Fix(IS_STRUCTURE); -NODES[18002].Fix(IS_STRUCTURE); -NODES[18006].Fix(IS_STRUCTURE); -NODES[18027].Fix(IS_STRUCTURE); -NODES[18028].Fix(IS_STRUCTURE); -NODES[18030].Fix(IS_STRUCTURE); -NODES[18032].Fix(IS_STRUCTURE); -NODES[18033].Fix(IS_STRUCTURE); -NODES[18040].Fix(IS_STRUCTURE); -NODES[18043].Fix(IS_STRUCTURE); -NODES[18046].Fix(IS_STRUCTURE); -NODES[18052].Fix(IS_STRUCTURE); -NODES[18053].Fix(IS_STRUCTURE); -NODES[18059].Fix(IS_STRUCTURE); -NODES[18064].Fix(IS_STRUCTURE); -NODES[18066].Fix(IS_STRUCTURE); -NODES[18068].Fix(IS_STRUCTURE); -NODES[18070].Fix(IS_STRUCTURE); -NODES[18071].Fix(IS_STRUCTURE); -NODES[18073].Fix(IS_STRUCTURE); -NODES[18080].Fix(IS_STRUCTURE); -NODES[18083].Fix(IS_STRUCTURE); -NODES[18084].Fix(IS_STRUCTURE); -NODES[18085].Fix(IS_STRUCTURE); -NODES[18086].Fix(IS_STRUCTURE); -NODES[18089].Fix(IS_STRUCTURE); -NODES[18095].Fix(IS_STRUCTURE); -NODES[18105].Fix(IS_STRUCTURE); -NODES[18106].Fix(IS_STRUCTURE); -NODES[18113].Fix(IS_STRUCTURE); -NODES[18115].Fix(IS_STRUCTURE); -NODES[18116].Fix(IS_STRUCTURE); -NODES[18118].Fix(IS_STRUCTURE); -NODES[18119].Fix(IS_STRUCTURE); -NODES[18120].Fix(IS_STRUCTURE); -NODES[18121].Fix(IS_STRUCTURE); -NODES[18125].Fix(IS_STRUCTURE); -NODES[18126].Fix(IS_STRUCTURE); -NODES[18136].Fix(IS_STRUCTURE); -NODES[18141].Fix(IS_STRUCTURE); -NODES[18142].Fix(IS_STRUCTURE); -NODES[18145].Fix(IS_STRUCTURE); -NODES[18147].Fix(IS_STRUCTURE); -NODES[18149].Fix(IS_STRUCTURE); -NODES[18150].Fix(IS_STRUCTURE); -NODES[18162].Fix(IS_STRUCTURE); -NODES[18163].Fix(IS_STRUCTURE); -NODES[18164].Fix(IS_STRUCTURE); -NODES[18167].Fix(IS_STRUCTURE); -NODES[18168].Fix(IS_STRUCTURE); -NODES[18170].Fix(IS_STRUCTURE); -NODES[18175].Fix(IS_STRUCTURE); -NODES[18180].Fix(IS_STRUCTURE); -NODES[18181].Fix(IS_STRUCTURE); -NODES[18184].Fix(IS_STRUCTURE); -NODES[18186].Fix(IS_STRUCTURE); -NODES[18190].Fix(IS_STRUCTURE); -NODES[18193].Fix(IS_STRUCTURE); -NODES[18197].Fix(IS_STRUCTURE); -NODES[18199].Fix(IS_STRUCTURE); -NODES[18203].Fix(IS_STRUCTURE); -NODES[18209].Fix(IS_STRUCTURE); -NODES[18214].Fix(IS_STRUCTURE); -NODES[18217].Fix(IS_STRUCTURE); -NODES[18218].Fix(IS_STRUCTURE); -NODES[18221].Fix(IS_STRUCTURE); -NODES[18225].Fix(IS_STRUCTURE); -NODES[18227].Fix(IS_STRUCTURE); -NODES[18233].Fix(IS_STRUCTURE); -NODES[18236].Fix(IS_STRUCTURE); -NODES[18242].Fix(IS_STRUCTURE); -NODES[18245].Fix(IS_STRUCTURE); -NODES[18247].Fix(IS_STRUCTURE); -NODES[18251].Fix(IS_STRUCTURE); -NODES[18255].Fix(IS_STRUCTURE); -NODES[18256].Fix(IS_STRUCTURE); -NODES[18259].Fix(IS_STRUCTURE); -NODES[18260].Fix(IS_STRUCTURE); -NODES[18261].Fix(IS_STRUCTURE); -NODES[18265].Fix(IS_STRUCTURE); -NODES[18266].Fix(IS_STRUCTURE); -NODES[18272].Fix(IS_STRUCTURE); -NODES[18273].Fix(IS_STRUCTURE); -NODES[18274].Fix(IS_STRUCTURE); -NODES[18284].Fix(IS_STRUCTURE); -NODES[18285].Fix(IS_STRUCTURE); -NODES[18286].Fix(IS_STRUCTURE); -NODES[18291].Fix(IS_STRUCTURE); -NODES[18300].Fix(IS_STRUCTURE); -NODES[18301].Fix(IS_STRUCTURE); -NODES[18303].Fix(IS_STRUCTURE); -NODES[18304].Fix(IS_STRUCTURE); -NODES[18306].Fix(IS_STRUCTURE); -NODES[18312].Fix(IS_STRUCTURE); -NODES[18316].Fix(IS_STRUCTURE); -NODES[18317].Fix(IS_STRUCTURE); -NODES[18322].Fix(IS_STRUCTURE); -NODES[18323].Fix(IS_STRUCTURE); -NODES[18325].Fix(IS_STRUCTURE); -NODES[18331].Fix(IS_STRUCTURE); -NODES[18337].Fix(IS_STRUCTURE); -NODES[18338].Fix(IS_STRUCTURE); -NODES[18339].Fix(IS_STRUCTURE); -NODES[18340].Fix(IS_STRUCTURE); -NODES[18341].Fix(IS_STRUCTURE); -NODES[18342].Fix(IS_STRUCTURE); -NODES[18343].Fix(IS_STRUCTURE); -NODES[18351].Fix(IS_STRUCTURE); -NODES[18352].Fix(IS_STRUCTURE); -NODES[18353].Fix(IS_STRUCTURE); -NODES[18356].Fix(IS_STRUCTURE); -NODES[18358].Fix(IS_STRUCTURE); -NODES[18359].Fix(IS_STRUCTURE); -NODES[18360].Fix(IS_STRUCTURE); -NODES[18361].Fix(IS_STRUCTURE); -NODES[18365].Fix(IS_STRUCTURE); -NODES[18367].Fix(IS_STRUCTURE); -NODES[18369].Fix(IS_STRUCTURE); -NODES[18372].Fix(IS_STRUCTURE); -NODES[18373].Fix(IS_STRUCTURE); -NODES[18379].Fix(IS_STRUCTURE); -NODES[18381].Fix(IS_STRUCTURE); -NODES[18382].Fix(IS_STRUCTURE); -NODES[18384].Fix(IS_STRUCTURE); -NODES[18386].Fix(IS_STRUCTURE); -NODES[18390].Fix(IS_STRUCTURE); -NODES[18394].Fix(IS_STRUCTURE); -NODES[18400].Fix(IS_STRUCTURE); -NODES[18401].Fix(IS_STRUCTURE); -NODES[18402].Fix(IS_STRUCTURE); -NODES[18403].Fix(IS_STRUCTURE); -NODES[18404].Fix(IS_STRUCTURE); -NODES[18406].Fix(IS_STRUCTURE); -NODES[18408].Fix(IS_STRUCTURE); -NODES[18409].Fix(IS_STRUCTURE); -NODES[18410].Fix(IS_STRUCTURE); -NODES[18415].Fix(IS_STRUCTURE); -NODES[18422].Fix(IS_STRUCTURE); -NODES[18424].Fix(IS_STRUCTURE); -NODES[18425].Fix(IS_STRUCTURE); -NODES[18428].Fix(IS_STRUCTURE); -NODES[18433].Fix(IS_STRUCTURE); -NODES[18435].Fix(IS_STRUCTURE); -NODES[18437].Fix(IS_STRUCTURE); -NODES[18439].Fix(IS_STRUCTURE); -NODES[18441].Fix(IS_STRUCTURE); -NODES[18443].Fix(IS_STRUCTURE); -NODES[18446].Fix(IS_STRUCTURE); -NODES[18448].Fix(IS_STRUCTURE); -NODES[18449].Fix(IS_STRUCTURE); -NODES[18453].Fix(IS_STRUCTURE); -NODES[18455].Fix(IS_STRUCTURE); -NODES[18456].Fix(IS_STRUCTURE); -NODES[18457].Fix(IS_STRUCTURE); -NODES[18461].Fix(IS_STRUCTURE); -NODES[18465].Fix(IS_STRUCTURE); -NODES[18466].Fix(IS_STRUCTURE); -NODES[18467].Fix(IS_STRUCTURE); -NODES[18468].Fix(IS_STRUCTURE); -NODES[18469].Fix(IS_STRUCTURE); -NODES[18471].Fix(IS_STRUCTURE); -NODES[18476].Fix(IS_STRUCTURE); -NODES[18478].Fix(IS_STRUCTURE); -NODES[18479].Fix(IS_STRUCTURE); -NODES[18481].Fix(IS_STRUCTURE); -NODES[18482].Fix(IS_STRUCTURE); -NODES[18483].Fix(IS_STRUCTURE); -NODES[18490].Fix(IS_STRUCTURE); -NODES[18492].Fix(IS_STRUCTURE); -NODES[18494].Fix(IS_STRUCTURE); -NODES[18497].Fix(IS_STRUCTURE); -NODES[18498].Fix(IS_STRUCTURE); -NODES[18499].Fix(IS_STRUCTURE); -NODES[18500].Fix(IS_STRUCTURE); -NODES[18503].Fix(IS_STRUCTURE); -NODES[18505].Fix(IS_STRUCTURE); -NODES[18506].Fix(IS_STRUCTURE); -NODES[18508].Fix(IS_STRUCTURE); -NODES[18509].Fix(IS_STRUCTURE); -NODES[18512].Fix(IS_STRUCTURE); -NODES[18514].Fix(IS_STRUCTURE); -NODES[18515].Fix(IS_STRUCTURE); -NODES[18516].Fix(IS_STRUCTURE); -NODES[18517].Fix(IS_STRUCTURE); -NODES[18519].Fix(IS_STRUCTURE); -NODES[18521].Fix(IS_STRUCTURE); -NODES[18523].Fix(IS_STRUCTURE); -NODES[18527].Fix(IS_STRUCTURE); -NODES[18530].Fix(IS_STRUCTURE); -NODES[18531].Fix(IS_STRUCTURE); -NODES[18533].Fix(IS_STRUCTURE); -NODES[18536].Fix(IS_STRUCTURE); -NODES[18538].Fix(IS_STRUCTURE); -NODES[18539].Fix(IS_STRUCTURE); -NODES[18540].Fix(IS_STRUCTURE); -NODES[18541].Fix(IS_STRUCTURE); -NODES[18542].Fix(IS_STRUCTURE); -NODES[18543].Fix(IS_STRUCTURE); -NODES[18544].Fix(IS_STRUCTURE); -NODES[18545].Fix(IS_STRUCTURE); -NODES[18546].Fix(IS_STRUCTURE); -NODES[18554].Fix(IS_STRUCTURE); -NODES[18556].Fix(IS_STRUCTURE); -NODES[18557].Fix(IS_STRUCTURE); -NODES[18558].Fix(IS_STRUCTURE); -NODES[18559].Fix(IS_STRUCTURE); -NODES[18560].Fix(IS_STRUCTURE); -NODES[18562].Fix(IS_STRUCTURE); -NODES[18563].Fix(IS_STRUCTURE); -NODES[18564].Fix(IS_STRUCTURE); -NODES[18568].Fix(IS_STRUCTURE); -NODES[18569].Fix(IS_STRUCTURE); -NODES[18570].Fix(IS_STRUCTURE); -NODES[18573].Fix(IS_STRUCTURE); -NODES[18575].Fix(IS_STRUCTURE); -NODES[18576].Fix(IS_STRUCTURE); -NODES[18577].Fix(IS_STRUCTURE); -NODES[18579].Fix(IS_STRUCTURE); -NODES[18580].Fix(IS_STRUCTURE); -NODES[18581].Fix(IS_STRUCTURE); -NODES[18582].Fix(IS_STRUCTURE); -NODES[18585].Fix(IS_STRUCTURE); -NODES[18589].Fix(IS_STRUCTURE); -NODES[18590].Fix(IS_STRUCTURE); -NODES[18591].Fix(IS_STRUCTURE); -NODES[18592].Fix(IS_STRUCTURE); -NODES[18593].Fix(IS_STRUCTURE); -NODES[18594].Fix(IS_STRUCTURE); -NODES[18595].Fix(IS_STRUCTURE); -NODES[18597].Fix(IS_STRUCTURE); -NODES[18601].Fix(IS_STRUCTURE); -NODES[18604].Fix(IS_STRUCTURE); -NODES[18605].Fix(IS_STRUCTURE); -NODES[18609].Fix(IS_STRUCTURE); -NODES[18610].Fix(IS_STRUCTURE); -NODES[18611].Fix(IS_STRUCTURE); -NODES[18612].Fix(IS_STRUCTURE); -NODES[18613].Fix(IS_STRUCTURE); -NODES[18616].Fix(IS_STRUCTURE); -NODES[18618].Fix(IS_STRUCTURE); -NODES[18619].Fix(IS_STRUCTURE); -NODES[18621].Fix(IS_STRUCTURE); -NODES[18622].Fix(IS_STRUCTURE); -NODES[18623].Fix(IS_STRUCTURE); -NODES[18624].Fix(IS_STRUCTURE); -NODES[18626].Fix(IS_STRUCTURE); -NODES[18629].Fix(IS_STRUCTURE); -NODES[18630].Fix(IS_STRUCTURE); -NODES[18632].Fix(IS_STRUCTURE); -NODES[18633].Fix(IS_STRUCTURE); -NODES[18634].Fix(IS_STRUCTURE); -NODES[18635].Fix(IS_STRUCTURE); -NODES[18636].Fix(IS_STRUCTURE); -NODES[18639].Fix(IS_STRUCTURE); -NODES[18641].Fix(IS_STRUCTURE); -NODES[18642].Fix(IS_STRUCTURE); -NODES[18644].Fix(IS_STRUCTURE); -NODES[18645].Fix(IS_STRUCTURE); -NODES[18646].Fix(IS_STRUCTURE); -NODES[18647].Fix(IS_STRUCTURE); -NODES[18654].Fix(IS_STRUCTURE); -NODES[18657].Fix(IS_STRUCTURE); -NODES[18658].Fix(IS_STRUCTURE); -NODES[18659].Fix(IS_STRUCTURE); -NODES[18660].Fix(IS_STRUCTURE); -NODES[18661].Fix(IS_STRUCTURE); -NODES[18662].Fix(IS_STRUCTURE); -NODES[18663].Fix(IS_STRUCTURE); -NODES[18664].Fix(IS_STRUCTURE); -NODES[18666].Fix(IS_STRUCTURE); -NODES[18667].Fix(IS_STRUCTURE); -NODES[18668].Fix(IS_STRUCTURE); -NODES[18669].Fix(IS_STRUCTURE); -NODES[18672].Fix(IS_STRUCTURE); -NODES[18673].Fix(IS_STRUCTURE); -NODES[18674].Fix(IS_STRUCTURE); -NODES[18676].Fix(IS_STRUCTURE); -NODES[18677].Fix(IS_STRUCTURE); -NODES[18680].Fix(IS_STRUCTURE); -NODES[18681].Fix(IS_STRUCTURE); -NODES[18682].Fix(IS_STRUCTURE); -NODES[18683].Fix(IS_STRUCTURE); -NODES[18684].Fix(IS_STRUCTURE); -NODES[18686].Fix(IS_STRUCTURE); -NODES[18687].Fix(IS_STRUCTURE); -NODES[18688].Fix(IS_STRUCTURE); -NODES[18689].Fix(IS_STRUCTURE); -NODES[18690].Fix(IS_STRUCTURE); -NODES[18692].Fix(IS_STRUCTURE); -NODES[18693].Fix(IS_STRUCTURE); -NODES[18694].Fix(IS_STRUCTURE); -NODES[18695].Fix(IS_STRUCTURE); -NODES[18696].Fix(IS_STRUCTURE); -NODES[18697].Fix(IS_STRUCTURE); -NODES[18698].Fix(IS_STRUCTURE); -NODES[18699].Fix(IS_STRUCTURE); -NODES[1].Fix(VELOCITY_X); -NODES[1].Fix(VELOCITY_Y); -NODES[1].Fix(VELOCITY_Z); -NODES[2].Fix(VELOCITY_X); -NODES[2].Fix(VELOCITY_Y); -NODES[2].Fix(VELOCITY_Z); -NODES[3].Fix(VELOCITY_X); -NODES[3].Fix(VELOCITY_Y); -NODES[3].Fix(VELOCITY_Z); -NODES[4].Fix(VELOCITY_X); -NODES[4].Fix(VELOCITY_Y); -NODES[4].Fix(VELOCITY_Z); -NODES[5].Fix(VELOCITY_X); -NODES[5].Fix(VELOCITY_Y); -NODES[5].Fix(VELOCITY_Z); -NODES[6].Fix(VELOCITY_X); -NODES[6].Fix(VELOCITY_Y); -NODES[6].Fix(VELOCITY_Z); -NODES[7].Fix(VELOCITY_X); -NODES[7].Fix(VELOCITY_Y); -NODES[7].Fix(VELOCITY_Z); -NODES[8].Fix(VELOCITY_X); -NODES[8].Fix(VELOCITY_Y); -NODES[8].Fix(VELOCITY_Z); -NODES[9].Fix(VELOCITY_X); -NODES[9].Fix(VELOCITY_Y); -NODES[9].Fix(VELOCITY_Z); -NODES[10].Fix(VELOCITY_X); -NODES[10].Fix(VELOCITY_Y); -NODES[10].Fix(VELOCITY_Z); -NODES[11].Fix(VELOCITY_X); -NODES[11].Fix(VELOCITY_Y); -NODES[11].Fix(VELOCITY_Z); -NODES[12].Fix(VELOCITY_X); -NODES[12].Fix(VELOCITY_Y); -NODES[12].Fix(VELOCITY_Z); -NODES[13].Fix(VELOCITY_X); -NODES[13].Fix(VELOCITY_Y); -NODES[13].Fix(VELOCITY_Z); -NODES[14].Fix(VELOCITY_X); -NODES[14].Fix(VELOCITY_Y); -NODES[14].Fix(VELOCITY_Z); -NODES[15].Fix(VELOCITY_X); -NODES[15].Fix(VELOCITY_Y); -NODES[15].Fix(VELOCITY_Z); -NODES[16].Fix(VELOCITY_X); -NODES[16].Fix(VELOCITY_Y); -NODES[16].Fix(VELOCITY_Z); -NODES[17].Fix(VELOCITY_X); -NODES[17].Fix(VELOCITY_Y); -NODES[17].Fix(VELOCITY_Z); -NODES[18].Fix(VELOCITY_X); -NODES[18].Fix(VELOCITY_Y); -NODES[18].Fix(VELOCITY_Z); -NODES[19].Fix(VELOCITY_X); -NODES[19].Fix(VELOCITY_Y); -NODES[19].Fix(VELOCITY_Z); -NODES[20].Fix(VELOCITY_X); -NODES[20].Fix(VELOCITY_Y); -NODES[20].Fix(VELOCITY_Z); -NODES[21].Fix(VELOCITY_X); -NODES[21].Fix(VELOCITY_Y); -NODES[21].Fix(VELOCITY_Z); -NODES[22].Fix(VELOCITY_X); -NODES[22].Fix(VELOCITY_Y); -NODES[22].Fix(VELOCITY_Z); -NODES[23].Fix(VELOCITY_X); -NODES[23].Fix(VELOCITY_Y); -NODES[23].Fix(VELOCITY_Z); -NODES[24].Fix(VELOCITY_X); -NODES[24].Fix(VELOCITY_Y); -NODES[24].Fix(VELOCITY_Z); -NODES[25].Fix(VELOCITY_X); -NODES[25].Fix(VELOCITY_Y); -NODES[25].Fix(VELOCITY_Z); -NODES[26].Fix(VELOCITY_X); -NODES[26].Fix(VELOCITY_Y); -NODES[26].Fix(VELOCITY_Z); -NODES[27].Fix(VELOCITY_X); -NODES[27].Fix(VELOCITY_Y); -NODES[27].Fix(VELOCITY_Z); -NODES[28].Fix(VELOCITY_X); -NODES[28].Fix(VELOCITY_Y); -NODES[28].Fix(VELOCITY_Z); -NODES[29].Fix(VELOCITY_X); -NODES[29].Fix(VELOCITY_Y); -NODES[29].Fix(VELOCITY_Z); -NODES[30].Fix(VELOCITY_X); -NODES[30].Fix(VELOCITY_Y); -NODES[30].Fix(VELOCITY_Z); -NODES[31].Fix(VELOCITY_X); -NODES[31].Fix(VELOCITY_Y); -NODES[31].Fix(VELOCITY_Z); -NODES[32].Fix(VELOCITY_X); -NODES[32].Fix(VELOCITY_Y); -NODES[32].Fix(VELOCITY_Z); -NODES[33].Fix(VELOCITY_X); -NODES[33].Fix(VELOCITY_Y); -NODES[33].Fix(VELOCITY_Z); -NODES[34].Fix(VELOCITY_X); -NODES[34].Fix(VELOCITY_Y); -NODES[34].Fix(VELOCITY_Z); -NODES[35].Fix(VELOCITY_X); -NODES[35].Fix(VELOCITY_Y); -NODES[35].Fix(VELOCITY_Z); -NODES[36].Fix(VELOCITY_X); -NODES[36].Fix(VELOCITY_Y); -NODES[36].Fix(VELOCITY_Z); -NODES[37].Fix(VELOCITY_X); -NODES[37].Fix(VELOCITY_Y); -NODES[37].Fix(VELOCITY_Z); -NODES[38].Fix(VELOCITY_X); -NODES[38].Fix(VELOCITY_Y); -NODES[38].Fix(VELOCITY_Z); -NODES[39].Fix(VELOCITY_X); -NODES[39].Fix(VELOCITY_Y); -NODES[39].Fix(VELOCITY_Z); -NODES[40].Fix(VELOCITY_X); -NODES[40].Fix(VELOCITY_Y); -NODES[40].Fix(VELOCITY_Z); -NODES[41].Fix(VELOCITY_X); -NODES[41].Fix(VELOCITY_Y); -NODES[41].Fix(VELOCITY_Z); -NODES[42].Fix(VELOCITY_X); -NODES[42].Fix(VELOCITY_Y); -NODES[42].Fix(VELOCITY_Z); -NODES[43].Fix(VELOCITY_X); -NODES[43].Fix(VELOCITY_Y); -NODES[43].Fix(VELOCITY_Z); -NODES[44].Fix(VELOCITY_X); -NODES[44].Fix(VELOCITY_Y); -NODES[44].Fix(VELOCITY_Z); -NODES[45].Fix(VELOCITY_X); -NODES[45].Fix(VELOCITY_Y); -NODES[45].Fix(VELOCITY_Z); -NODES[46].Fix(VELOCITY_X); -NODES[46].Fix(VELOCITY_Y); -NODES[46].Fix(VELOCITY_Z); -NODES[47].Fix(VELOCITY_X); -NODES[47].Fix(VELOCITY_Y); -NODES[47].Fix(VELOCITY_Z); -NODES[48].Fix(VELOCITY_X); -NODES[48].Fix(VELOCITY_Y); -NODES[48].Fix(VELOCITY_Z); -NODES[49].Fix(VELOCITY_X); -NODES[49].Fix(VELOCITY_Y); -NODES[49].Fix(VELOCITY_Z); -NODES[50].Fix(VELOCITY_X); -NODES[50].Fix(VELOCITY_Y); -NODES[50].Fix(VELOCITY_Z); -NODES[51].Fix(VELOCITY_X); -NODES[51].Fix(VELOCITY_Y); -NODES[51].Fix(VELOCITY_Z); -NODES[52].Fix(VELOCITY_X); -NODES[52].Fix(VELOCITY_Y); -NODES[52].Fix(VELOCITY_Z); -NODES[53].Fix(VELOCITY_X); -NODES[53].Fix(VELOCITY_Y); -NODES[53].Fix(VELOCITY_Z); -NODES[54].Fix(VELOCITY_X); -NODES[54].Fix(VELOCITY_Y); -NODES[54].Fix(VELOCITY_Z); -NODES[55].Fix(VELOCITY_X); -NODES[55].Fix(VELOCITY_Y); -NODES[55].Fix(VELOCITY_Z); -NODES[56].Fix(VELOCITY_X); -NODES[56].Fix(VELOCITY_Y); -NODES[56].Fix(VELOCITY_Z); -NODES[57].Fix(VELOCITY_X); -NODES[57].Fix(VELOCITY_Y); -NODES[57].Fix(VELOCITY_Z); -NODES[58].Fix(VELOCITY_X); -NODES[58].Fix(VELOCITY_Y); -NODES[58].Fix(VELOCITY_Z); -NODES[59].Fix(VELOCITY_X); -NODES[59].Fix(VELOCITY_Y); -NODES[59].Fix(VELOCITY_Z); -NODES[60].Fix(VELOCITY_X); -NODES[60].Fix(VELOCITY_Y); -NODES[60].Fix(VELOCITY_Z); -NODES[61].Fix(VELOCITY_X); -NODES[61].Fix(VELOCITY_Y); -NODES[61].Fix(VELOCITY_Z); -NODES[62].Fix(VELOCITY_X); -NODES[62].Fix(VELOCITY_Y); -NODES[62].Fix(VELOCITY_Z); -NODES[63].Fix(VELOCITY_X); -NODES[63].Fix(VELOCITY_Y); -NODES[63].Fix(VELOCITY_Z); -NODES[64].Fix(VELOCITY_X); -NODES[64].Fix(VELOCITY_Y); -NODES[64].Fix(VELOCITY_Z); -NODES[65].Fix(VELOCITY_X); -NODES[65].Fix(VELOCITY_Y); -NODES[65].Fix(VELOCITY_Z); -NODES[66].Fix(VELOCITY_X); -NODES[66].Fix(VELOCITY_Y); -NODES[66].Fix(VELOCITY_Z); -NODES[67].Fix(VELOCITY_X); -NODES[67].Fix(VELOCITY_Y); -NODES[67].Fix(VELOCITY_Z); -NODES[68].Fix(VELOCITY_X); -NODES[68].Fix(VELOCITY_Y); -NODES[68].Fix(VELOCITY_Z); -NODES[69].Fix(VELOCITY_X); -NODES[69].Fix(VELOCITY_Y); -NODES[69].Fix(VELOCITY_Z); -NODES[70].Fix(VELOCITY_X); -NODES[70].Fix(VELOCITY_Y); -NODES[70].Fix(VELOCITY_Z); -NODES[71].Fix(VELOCITY_X); -NODES[71].Fix(VELOCITY_Y); -NODES[71].Fix(VELOCITY_Z); -NODES[72].Fix(VELOCITY_X); -NODES[72].Fix(VELOCITY_Y); -NODES[72].Fix(VELOCITY_Z); -NODES[73].Fix(VELOCITY_X); -NODES[73].Fix(VELOCITY_Y); -NODES[73].Fix(VELOCITY_Z); -NODES[74].Fix(VELOCITY_X); -NODES[74].Fix(VELOCITY_Y); -NODES[74].Fix(VELOCITY_Z); -NODES[75].Fix(VELOCITY_X); -NODES[75].Fix(VELOCITY_Y); -NODES[75].Fix(VELOCITY_Z); -NODES[76].Fix(VELOCITY_X); -NODES[76].Fix(VELOCITY_Y); -NODES[76].Fix(VELOCITY_Z); -NODES[77].Fix(VELOCITY_X); -NODES[77].Fix(VELOCITY_Y); -NODES[77].Fix(VELOCITY_Z); -NODES[78].Fix(VELOCITY_X); -NODES[78].Fix(VELOCITY_Y); -NODES[78].Fix(VELOCITY_Z); -NODES[79].Fix(VELOCITY_X); -NODES[79].Fix(VELOCITY_Y); -NODES[79].Fix(VELOCITY_Z); -NODES[80].Fix(VELOCITY_X); -NODES[80].Fix(VELOCITY_Y); -NODES[80].Fix(VELOCITY_Z); -NODES[81].Fix(VELOCITY_X); -NODES[81].Fix(VELOCITY_Y); -NODES[81].Fix(VELOCITY_Z); -NODES[82].Fix(VELOCITY_X); -NODES[82].Fix(VELOCITY_Y); -NODES[82].Fix(VELOCITY_Z); -NODES[83].Fix(VELOCITY_X); -NODES[83].Fix(VELOCITY_Y); -NODES[83].Fix(VELOCITY_Z); -NODES[84].Fix(VELOCITY_X); -NODES[84].Fix(VELOCITY_Y); -NODES[84].Fix(VELOCITY_Z); -NODES[85].Fix(VELOCITY_X); -NODES[85].Fix(VELOCITY_Y); -NODES[85].Fix(VELOCITY_Z); -NODES[86].Fix(VELOCITY_X); -NODES[86].Fix(VELOCITY_Y); -NODES[86].Fix(VELOCITY_Z); -NODES[87].Fix(VELOCITY_X); -NODES[87].Fix(VELOCITY_Y); -NODES[87].Fix(VELOCITY_Z); -NODES[88].Fix(VELOCITY_X); -NODES[88].Fix(VELOCITY_Y); -NODES[88].Fix(VELOCITY_Z); -NODES[89].Fix(VELOCITY_X); -NODES[89].Fix(VELOCITY_Y); -NODES[89].Fix(VELOCITY_Z); -NODES[90].Fix(VELOCITY_X); -NODES[90].Fix(VELOCITY_Y); -NODES[90].Fix(VELOCITY_Z); -NODES[91].Fix(VELOCITY_X); -NODES[91].Fix(VELOCITY_Y); -NODES[91].Fix(VELOCITY_Z); -NODES[92].Fix(VELOCITY_X); -NODES[92].Fix(VELOCITY_Y); -NODES[92].Fix(VELOCITY_Z); -NODES[93].Fix(VELOCITY_X); -NODES[93].Fix(VELOCITY_Y); -NODES[93].Fix(VELOCITY_Z); -NODES[94].Fix(VELOCITY_X); -NODES[94].Fix(VELOCITY_Y); -NODES[94].Fix(VELOCITY_Z); -NODES[95].Fix(VELOCITY_X); -NODES[95].Fix(VELOCITY_Y); -NODES[95].Fix(VELOCITY_Z); -NODES[96].Fix(VELOCITY_X); -NODES[96].Fix(VELOCITY_Y); -NODES[96].Fix(VELOCITY_Z); -NODES[97].Fix(VELOCITY_X); -NODES[97].Fix(VELOCITY_Y); -NODES[97].Fix(VELOCITY_Z); -NODES[98].Fix(VELOCITY_X); -NODES[98].Fix(VELOCITY_Y); -NODES[98].Fix(VELOCITY_Z); -NODES[99].Fix(VELOCITY_X); -NODES[99].Fix(VELOCITY_Y); -NODES[99].Fix(VELOCITY_Z); -NODES[100].Fix(VELOCITY_X); -NODES[100].Fix(VELOCITY_Y); -NODES[100].Fix(VELOCITY_Z); -NODES[101].Fix(VELOCITY_X); -NODES[101].Fix(VELOCITY_Y); -NODES[101].Fix(VELOCITY_Z); -NODES[102].Fix(VELOCITY_X); -NODES[102].Fix(VELOCITY_Y); -NODES[102].Fix(VELOCITY_Z); -NODES[103].Fix(VELOCITY_X); -NODES[103].Fix(VELOCITY_Y); -NODES[103].Fix(VELOCITY_Z); -NODES[104].Fix(VELOCITY_X); -NODES[104].Fix(VELOCITY_Y); -NODES[104].Fix(VELOCITY_Z); -NODES[105].Fix(VELOCITY_X); -NODES[105].Fix(VELOCITY_Y); -NODES[105].Fix(VELOCITY_Z); -NODES[106].Fix(VELOCITY_X); -NODES[106].Fix(VELOCITY_Y); -NODES[106].Fix(VELOCITY_Z); -NODES[107].Fix(VELOCITY_X); -NODES[107].Fix(VELOCITY_Y); -NODES[107].Fix(VELOCITY_Z); -NODES[108].Fix(VELOCITY_X); -NODES[108].Fix(VELOCITY_Y); -NODES[108].Fix(VELOCITY_Z); -NODES[109].Fix(VELOCITY_X); -NODES[109].Fix(VELOCITY_Y); -NODES[109].Fix(VELOCITY_Z); -NODES[110].Fix(VELOCITY_X); -NODES[110].Fix(VELOCITY_Y); -NODES[110].Fix(VELOCITY_Z); -NODES[111].Fix(VELOCITY_X); -NODES[111].Fix(VELOCITY_Y); -NODES[111].Fix(VELOCITY_Z); -NODES[112].Fix(VELOCITY_X); -NODES[112].Fix(VELOCITY_Y); -NODES[112].Fix(VELOCITY_Z); -NODES[113].Fix(VELOCITY_X); -NODES[113].Fix(VELOCITY_Y); -NODES[113].Fix(VELOCITY_Z); -NODES[114].Fix(VELOCITY_X); -NODES[114].Fix(VELOCITY_Y); -NODES[114].Fix(VELOCITY_Z); -NODES[115].Fix(VELOCITY_X); -NODES[115].Fix(VELOCITY_Y); -NODES[115].Fix(VELOCITY_Z); -NODES[116].Fix(VELOCITY_X); -NODES[116].Fix(VELOCITY_Y); -NODES[116].Fix(VELOCITY_Z); -NODES[117].Fix(VELOCITY_X); -NODES[117].Fix(VELOCITY_Y); -NODES[117].Fix(VELOCITY_Z); -NODES[118].Fix(VELOCITY_X); -NODES[118].Fix(VELOCITY_Y); -NODES[118].Fix(VELOCITY_Z); -NODES[119].Fix(VELOCITY_X); -NODES[119].Fix(VELOCITY_Y); -NODES[119].Fix(VELOCITY_Z); -NODES[120].Fix(VELOCITY_X); -NODES[120].Fix(VELOCITY_Y); -NODES[120].Fix(VELOCITY_Z); -NODES[121].Fix(VELOCITY_X); -NODES[121].Fix(VELOCITY_Y); -NODES[121].Fix(VELOCITY_Z); -NODES[122].Fix(VELOCITY_X); -NODES[122].Fix(VELOCITY_Y); -NODES[122].Fix(VELOCITY_Z); -NODES[123].Fix(VELOCITY_X); -NODES[123].Fix(VELOCITY_Y); -NODES[123].Fix(VELOCITY_Z); -NODES[124].Fix(VELOCITY_X); -NODES[124].Fix(VELOCITY_Y); -NODES[124].Fix(VELOCITY_Z); -NODES[125].Fix(VELOCITY_X); -NODES[125].Fix(VELOCITY_Y); -NODES[125].Fix(VELOCITY_Z); -NODES[126].Fix(VELOCITY_X); -NODES[126].Fix(VELOCITY_Y); -NODES[126].Fix(VELOCITY_Z); -NODES[127].Fix(VELOCITY_X); -NODES[127].Fix(VELOCITY_Y); -NODES[127].Fix(VELOCITY_Z); -NODES[128].Fix(VELOCITY_X); -NODES[128].Fix(VELOCITY_Y); -NODES[128].Fix(VELOCITY_Z); -NODES[129].Fix(VELOCITY_X); -NODES[129].Fix(VELOCITY_Y); -NODES[129].Fix(VELOCITY_Z); -NODES[130].Fix(VELOCITY_X); -NODES[130].Fix(VELOCITY_Y); -NODES[130].Fix(VELOCITY_Z); -NODES[131].Fix(VELOCITY_X); -NODES[131].Fix(VELOCITY_Y); -NODES[131].Fix(VELOCITY_Z); -NODES[132].Fix(VELOCITY_X); -NODES[132].Fix(VELOCITY_Y); -NODES[132].Fix(VELOCITY_Z); -NODES[133].Fix(VELOCITY_X); -NODES[133].Fix(VELOCITY_Y); -NODES[133].Fix(VELOCITY_Z); -NODES[134].Fix(VELOCITY_X); -NODES[134].Fix(VELOCITY_Y); -NODES[134].Fix(VELOCITY_Z); -NODES[135].Fix(VELOCITY_X); -NODES[135].Fix(VELOCITY_Y); -NODES[135].Fix(VELOCITY_Z); -NODES[136].Fix(VELOCITY_X); -NODES[136].Fix(VELOCITY_Y); -NODES[136].Fix(VELOCITY_Z); -NODES[137].Fix(VELOCITY_X); -NODES[137].Fix(VELOCITY_Y); -NODES[137].Fix(VELOCITY_Z); -NODES[138].Fix(VELOCITY_X); -NODES[138].Fix(VELOCITY_Y); -NODES[138].Fix(VELOCITY_Z); -NODES[139].Fix(VELOCITY_X); -NODES[139].Fix(VELOCITY_Y); -NODES[139].Fix(VELOCITY_Z); -NODES[140].Fix(VELOCITY_X); -NODES[140].Fix(VELOCITY_Y); -NODES[140].Fix(VELOCITY_Z); -NODES[141].Fix(VELOCITY_X); -NODES[141].Fix(VELOCITY_Y); -NODES[141].Fix(VELOCITY_Z); -NODES[142].Fix(VELOCITY_X); -NODES[142].Fix(VELOCITY_Y); -NODES[142].Fix(VELOCITY_Z); -NODES[143].Fix(VELOCITY_X); -NODES[143].Fix(VELOCITY_Y); -NODES[143].Fix(VELOCITY_Z); -NODES[144].Fix(VELOCITY_X); -NODES[144].Fix(VELOCITY_Y); -NODES[144].Fix(VELOCITY_Z); -NODES[145].Fix(VELOCITY_X); -NODES[145].Fix(VELOCITY_Y); -NODES[145].Fix(VELOCITY_Z); -NODES[146].Fix(VELOCITY_X); -NODES[146].Fix(VELOCITY_Y); -NODES[146].Fix(VELOCITY_Z); -NODES[147].Fix(VELOCITY_X); -NODES[147].Fix(VELOCITY_Y); -NODES[147].Fix(VELOCITY_Z); -NODES[148].Fix(VELOCITY_X); -NODES[148].Fix(VELOCITY_Y); -NODES[148].Fix(VELOCITY_Z); -NODES[149].Fix(VELOCITY_X); -NODES[149].Fix(VELOCITY_Y); -NODES[149].Fix(VELOCITY_Z); -NODES[150].Fix(VELOCITY_X); -NODES[150].Fix(VELOCITY_Y); -NODES[150].Fix(VELOCITY_Z); -NODES[151].Fix(VELOCITY_X); -NODES[151].Fix(VELOCITY_Y); -NODES[151].Fix(VELOCITY_Z); -NODES[152].Fix(VELOCITY_X); -NODES[152].Fix(VELOCITY_Y); -NODES[152].Fix(VELOCITY_Z); -NODES[153].Fix(VELOCITY_X); -NODES[153].Fix(VELOCITY_Y); -NODES[153].Fix(VELOCITY_Z); -NODES[154].Fix(VELOCITY_X); -NODES[154].Fix(VELOCITY_Y); -NODES[154].Fix(VELOCITY_Z); -NODES[155].Fix(VELOCITY_X); -NODES[155].Fix(VELOCITY_Y); -NODES[155].Fix(VELOCITY_Z); -NODES[156].Fix(VELOCITY_X); -NODES[156].Fix(VELOCITY_Y); -NODES[156].Fix(VELOCITY_Z); -NODES[157].Fix(VELOCITY_X); -NODES[157].Fix(VELOCITY_Y); -NODES[157].Fix(VELOCITY_Z); -NODES[158].Fix(VELOCITY_X); -NODES[158].Fix(VELOCITY_Y); -NODES[158].Fix(VELOCITY_Z); -NODES[159].Fix(VELOCITY_X); -NODES[159].Fix(VELOCITY_Y); -NODES[159].Fix(VELOCITY_Z); -NODES[160].Fix(VELOCITY_X); -NODES[160].Fix(VELOCITY_Y); -NODES[160].Fix(VELOCITY_Z); -NODES[161].Fix(VELOCITY_X); -NODES[161].Fix(VELOCITY_Y); -NODES[161].Fix(VELOCITY_Z); -NODES[162].Fix(VELOCITY_X); -NODES[162].Fix(VELOCITY_Y); -NODES[162].Fix(VELOCITY_Z); -NODES[163].Fix(VELOCITY_X); -NODES[163].Fix(VELOCITY_Y); -NODES[163].Fix(VELOCITY_Z); -NODES[164].Fix(VELOCITY_X); -NODES[164].Fix(VELOCITY_Y); -NODES[164].Fix(VELOCITY_Z); -NODES[165].Fix(VELOCITY_X); -NODES[165].Fix(VELOCITY_Y); -NODES[165].Fix(VELOCITY_Z); -NODES[166].Fix(VELOCITY_X); -NODES[166].Fix(VELOCITY_Y); -NODES[166].Fix(VELOCITY_Z); -NODES[167].Fix(VELOCITY_X); -NODES[167].Fix(VELOCITY_Y); -NODES[167].Fix(VELOCITY_Z); -NODES[168].Fix(VELOCITY_X); -NODES[168].Fix(VELOCITY_Y); -NODES[168].Fix(VELOCITY_Z); -NODES[169].Fix(VELOCITY_X); -NODES[169].Fix(VELOCITY_Y); -NODES[169].Fix(VELOCITY_Z); -NODES[170].Fix(VELOCITY_X); -NODES[170].Fix(VELOCITY_Y); -NODES[170].Fix(VELOCITY_Z); -NODES[171].Fix(VELOCITY_X); -NODES[171].Fix(VELOCITY_Y); -NODES[171].Fix(VELOCITY_Z); -NODES[172].Fix(VELOCITY_X); -NODES[172].Fix(VELOCITY_Y); -NODES[172].Fix(VELOCITY_Z); -NODES[173].Fix(VELOCITY_X); -NODES[173].Fix(VELOCITY_Y); -NODES[173].Fix(VELOCITY_Z); -NODES[174].Fix(VELOCITY_X); -NODES[174].Fix(VELOCITY_Y); -NODES[174].Fix(VELOCITY_Z); -NODES[175].Fix(VELOCITY_X); -NODES[175].Fix(VELOCITY_Y); -NODES[175].Fix(VELOCITY_Z); -NODES[176].Fix(VELOCITY_X); -NODES[176].Fix(VELOCITY_Y); -NODES[176].Fix(VELOCITY_Z); -NODES[177].Fix(VELOCITY_X); -NODES[177].Fix(VELOCITY_Y); -NODES[177].Fix(VELOCITY_Z); -NODES[178].Fix(VELOCITY_X); -NODES[178].Fix(VELOCITY_Y); -NODES[178].Fix(VELOCITY_Z); -NODES[179].Fix(VELOCITY_X); -NODES[179].Fix(VELOCITY_Y); -NODES[179].Fix(VELOCITY_Z); -NODES[180].Fix(VELOCITY_X); -NODES[180].Fix(VELOCITY_Y); -NODES[180].Fix(VELOCITY_Z); -NODES[181].Fix(VELOCITY_X); -NODES[181].Fix(VELOCITY_Y); -NODES[181].Fix(VELOCITY_Z); -NODES[182].Fix(VELOCITY_X); -NODES[182].Fix(VELOCITY_Y); -NODES[182].Fix(VELOCITY_Z); -NODES[183].Fix(VELOCITY_X); -NODES[183].Fix(VELOCITY_Y); -NODES[183].Fix(VELOCITY_Z); -NODES[184].Fix(VELOCITY_X); -NODES[184].Fix(VELOCITY_Y); -NODES[184].Fix(VELOCITY_Z); -NODES[185].Fix(VELOCITY_X); -NODES[185].Fix(VELOCITY_Y); -NODES[185].Fix(VELOCITY_Z); -NODES[186].Fix(VELOCITY_X); -NODES[186].Fix(VELOCITY_Y); -NODES[186].Fix(VELOCITY_Z); -NODES[187].Fix(VELOCITY_X); -NODES[187].Fix(VELOCITY_Y); -NODES[187].Fix(VELOCITY_Z); -NODES[188].Fix(VELOCITY_X); -NODES[188].Fix(VELOCITY_Y); -NODES[188].Fix(VELOCITY_Z); -NODES[189].Fix(VELOCITY_X); -NODES[189].Fix(VELOCITY_Y); -NODES[189].Fix(VELOCITY_Z); -NODES[190].Fix(VELOCITY_X); -NODES[190].Fix(VELOCITY_Y); -NODES[190].Fix(VELOCITY_Z); -NODES[191].Fix(VELOCITY_X); -NODES[191].Fix(VELOCITY_Y); -NODES[191].Fix(VELOCITY_Z); -NODES[192].Fix(VELOCITY_X); -NODES[192].Fix(VELOCITY_Y); -NODES[192].Fix(VELOCITY_Z); -NODES[193].Fix(VELOCITY_X); -NODES[193].Fix(VELOCITY_Y); -NODES[193].Fix(VELOCITY_Z); -NODES[194].Fix(VELOCITY_X); -NODES[194].Fix(VELOCITY_Y); -NODES[194].Fix(VELOCITY_Z); -NODES[195].Fix(VELOCITY_X); -NODES[195].Fix(VELOCITY_Y); -NODES[195].Fix(VELOCITY_Z); -NODES[196].Fix(VELOCITY_X); -NODES[196].Fix(VELOCITY_Y); -NODES[196].Fix(VELOCITY_Z); -NODES[197].Fix(VELOCITY_X); -NODES[197].Fix(VELOCITY_Y); -NODES[197].Fix(VELOCITY_Z); -NODES[198].Fix(VELOCITY_X); -NODES[198].Fix(VELOCITY_Y); -NODES[198].Fix(VELOCITY_Z); -NODES[199].Fix(VELOCITY_X); -NODES[199].Fix(VELOCITY_Y); -NODES[199].Fix(VELOCITY_Z); -NODES[200].Fix(VELOCITY_X); -NODES[200].Fix(VELOCITY_Y); -NODES[200].Fix(VELOCITY_Z); -NODES[201].Fix(VELOCITY_X); -NODES[201].Fix(VELOCITY_Y); -NODES[201].Fix(VELOCITY_Z); -NODES[202].Fix(VELOCITY_X); -NODES[202].Fix(VELOCITY_Y); -NODES[202].Fix(VELOCITY_Z); -NODES[203].Fix(VELOCITY_X); -NODES[203].Fix(VELOCITY_Y); -NODES[203].Fix(VELOCITY_Z); -NODES[204].Fix(VELOCITY_X); -NODES[204].Fix(VELOCITY_Y); -NODES[204].Fix(VELOCITY_Z); -NODES[205].Fix(VELOCITY_X); -NODES[205].Fix(VELOCITY_Y); -NODES[205].Fix(VELOCITY_Z); -NODES[206].Fix(VELOCITY_X); -NODES[206].Fix(VELOCITY_Y); -NODES[206].Fix(VELOCITY_Z); -NODES[207].Fix(VELOCITY_X); -NODES[207].Fix(VELOCITY_Y); -NODES[207].Fix(VELOCITY_Z); -NODES[208].Fix(VELOCITY_X); -NODES[208].Fix(VELOCITY_Y); -NODES[208].Fix(VELOCITY_Z); -NODES[209].Fix(VELOCITY_X); -NODES[209].Fix(VELOCITY_Y); -NODES[209].Fix(VELOCITY_Z); -NODES[210].Fix(VELOCITY_X); -NODES[210].Fix(VELOCITY_Y); -NODES[210].Fix(VELOCITY_Z); -NODES[211].Fix(VELOCITY_X); -NODES[211].Fix(VELOCITY_Y); -NODES[211].Fix(VELOCITY_Z); -NODES[212].Fix(VELOCITY_X); -NODES[212].Fix(VELOCITY_Y); -NODES[212].Fix(VELOCITY_Z); -NODES[213].Fix(VELOCITY_X); -NODES[213].Fix(VELOCITY_Y); -NODES[213].Fix(VELOCITY_Z); -NODES[214].Fix(VELOCITY_X); -NODES[214].Fix(VELOCITY_Y); -NODES[214].Fix(VELOCITY_Z); -NODES[215].Fix(VELOCITY_X); -NODES[215].Fix(VELOCITY_Y); -NODES[215].Fix(VELOCITY_Z); -NODES[216].Fix(VELOCITY_X); -NODES[216].Fix(VELOCITY_Y); -NODES[216].Fix(VELOCITY_Z); -NODES[217].Fix(VELOCITY_X); -NODES[217].Fix(VELOCITY_Y); -NODES[217].Fix(VELOCITY_Z); -NODES[218].Fix(VELOCITY_X); -NODES[218].Fix(VELOCITY_Y); -NODES[218].Fix(VELOCITY_Z); -NODES[219].Fix(VELOCITY_X); -NODES[219].Fix(VELOCITY_Y); -NODES[219].Fix(VELOCITY_Z); -NODES[220].Fix(VELOCITY_X); -NODES[220].Fix(VELOCITY_Y); -NODES[220].Fix(VELOCITY_Z); -NODES[221].Fix(VELOCITY_X); -NODES[221].Fix(VELOCITY_Y); -NODES[221].Fix(VELOCITY_Z); -NODES[222].Fix(VELOCITY_X); -NODES[222].Fix(VELOCITY_Y); -NODES[222].Fix(VELOCITY_Z); -NODES[223].Fix(VELOCITY_X); -NODES[223].Fix(VELOCITY_Y); -NODES[223].Fix(VELOCITY_Z); -NODES[224].Fix(VELOCITY_X); -NODES[224].Fix(VELOCITY_Y); -NODES[224].Fix(VELOCITY_Z); -NODES[225].Fix(VELOCITY_X); -NODES[225].Fix(VELOCITY_Y); -NODES[225].Fix(VELOCITY_Z); -NODES[226].Fix(VELOCITY_X); -NODES[226].Fix(VELOCITY_Y); -NODES[226].Fix(VELOCITY_Z); -NODES[227].Fix(VELOCITY_X); -NODES[227].Fix(VELOCITY_Y); -NODES[227].Fix(VELOCITY_Z); -NODES[228].Fix(VELOCITY_X); -NODES[228].Fix(VELOCITY_Y); -NODES[228].Fix(VELOCITY_Z); -NODES[229].Fix(VELOCITY_X); -NODES[229].Fix(VELOCITY_Y); -NODES[229].Fix(VELOCITY_Z); -NODES[230].Fix(VELOCITY_X); -NODES[230].Fix(VELOCITY_Y); -NODES[230].Fix(VELOCITY_Z); -NODES[231].Fix(VELOCITY_X); -NODES[231].Fix(VELOCITY_Y); -NODES[231].Fix(VELOCITY_Z); -NODES[232].Fix(VELOCITY_X); -NODES[232].Fix(VELOCITY_Y); -NODES[232].Fix(VELOCITY_Z); -NODES[233].Fix(VELOCITY_X); -NODES[233].Fix(VELOCITY_Y); -NODES[233].Fix(VELOCITY_Z); -NODES[234].Fix(VELOCITY_X); -NODES[234].Fix(VELOCITY_Y); -NODES[234].Fix(VELOCITY_Z); -NODES[235].Fix(VELOCITY_X); -NODES[235].Fix(VELOCITY_Y); -NODES[235].Fix(VELOCITY_Z); -NODES[236].Fix(VELOCITY_X); -NODES[236].Fix(VELOCITY_Y); -NODES[236].Fix(VELOCITY_Z); -NODES[237].Fix(VELOCITY_X); -NODES[237].Fix(VELOCITY_Y); -NODES[237].Fix(VELOCITY_Z); -NODES[238].Fix(VELOCITY_X); -NODES[238].Fix(VELOCITY_Y); -NODES[238].Fix(VELOCITY_Z); -NODES[239].Fix(VELOCITY_X); -NODES[239].Fix(VELOCITY_Y); -NODES[239].Fix(VELOCITY_Z); -NODES[240].Fix(VELOCITY_X); -NODES[240].Fix(VELOCITY_Y); -NODES[240].Fix(VELOCITY_Z); -NODES[241].Fix(VELOCITY_X); -NODES[241].Fix(VELOCITY_Y); -NODES[241].Fix(VELOCITY_Z); -NODES[242].Fix(VELOCITY_X); -NODES[242].Fix(VELOCITY_Y); -NODES[242].Fix(VELOCITY_Z); -NODES[243].Fix(VELOCITY_X); -NODES[243].Fix(VELOCITY_Y); -NODES[243].Fix(VELOCITY_Z); -NODES[244].Fix(VELOCITY_X); -NODES[244].Fix(VELOCITY_Y); -NODES[244].Fix(VELOCITY_Z); -NODES[245].Fix(VELOCITY_X); -NODES[245].Fix(VELOCITY_Y); -NODES[245].Fix(VELOCITY_Z); -NODES[246].Fix(VELOCITY_X); -NODES[246].Fix(VELOCITY_Y); -NODES[246].Fix(VELOCITY_Z); -NODES[247].Fix(VELOCITY_X); -NODES[247].Fix(VELOCITY_Y); -NODES[247].Fix(VELOCITY_Z); -NODES[248].Fix(VELOCITY_X); -NODES[248].Fix(VELOCITY_Y); -NODES[248].Fix(VELOCITY_Z); -NODES[249].Fix(VELOCITY_X); -NODES[249].Fix(VELOCITY_Y); -NODES[249].Fix(VELOCITY_Z); -NODES[250].Fix(VELOCITY_X); -NODES[250].Fix(VELOCITY_Y); -NODES[250].Fix(VELOCITY_Z); -NODES[251].Fix(VELOCITY_X); -NODES[251].Fix(VELOCITY_Y); -NODES[251].Fix(VELOCITY_Z); -NODES[252].Fix(VELOCITY_X); -NODES[252].Fix(VELOCITY_Y); -NODES[252].Fix(VELOCITY_Z); -NODES[253].Fix(VELOCITY_X); -NODES[253].Fix(VELOCITY_Y); -NODES[253].Fix(VELOCITY_Z); -NODES[254].Fix(VELOCITY_X); -NODES[254].Fix(VELOCITY_Y); -NODES[254].Fix(VELOCITY_Z); -NODES[255].Fix(VELOCITY_X); -NODES[255].Fix(VELOCITY_Y); -NODES[255].Fix(VELOCITY_Z); -NODES[256].Fix(VELOCITY_X); -NODES[256].Fix(VELOCITY_Y); -NODES[256].Fix(VELOCITY_Z); -NODES[257].Fix(VELOCITY_X); -NODES[257].Fix(VELOCITY_Y); -NODES[257].Fix(VELOCITY_Z); -NODES[258].Fix(VELOCITY_X); -NODES[258].Fix(VELOCITY_Y); -NODES[258].Fix(VELOCITY_Z); -NODES[259].Fix(VELOCITY_X); -NODES[259].Fix(VELOCITY_Y); -NODES[259].Fix(VELOCITY_Z); -NODES[260].Fix(VELOCITY_X); -NODES[260].Fix(VELOCITY_Y); -NODES[260].Fix(VELOCITY_Z); -NODES[261].Fix(VELOCITY_X); -NODES[261].Fix(VELOCITY_Y); -NODES[261].Fix(VELOCITY_Z); -NODES[262].Fix(VELOCITY_X); -NODES[262].Fix(VELOCITY_Y); -NODES[262].Fix(VELOCITY_Z); -NODES[263].Fix(VELOCITY_X); -NODES[263].Fix(VELOCITY_Y); -NODES[263].Fix(VELOCITY_Z); -NODES[264].Fix(VELOCITY_X); -NODES[264].Fix(VELOCITY_Y); -NODES[264].Fix(VELOCITY_Z); -NODES[265].Fix(VELOCITY_X); -NODES[265].Fix(VELOCITY_Y); -NODES[265].Fix(VELOCITY_Z); -NODES[266].Fix(VELOCITY_X); -NODES[266].Fix(VELOCITY_Y); -NODES[266].Fix(VELOCITY_Z); -NODES[267].Fix(VELOCITY_X); -NODES[267].Fix(VELOCITY_Y); -NODES[267].Fix(VELOCITY_Z); -NODES[268].Fix(VELOCITY_X); -NODES[268].Fix(VELOCITY_Y); -NODES[268].Fix(VELOCITY_Z); -NODES[269].Fix(VELOCITY_X); -NODES[269].Fix(VELOCITY_Y); -NODES[269].Fix(VELOCITY_Z); -NODES[270].Fix(VELOCITY_X); -NODES[270].Fix(VELOCITY_Y); -NODES[270].Fix(VELOCITY_Z); -NODES[271].Fix(VELOCITY_X); -NODES[271].Fix(VELOCITY_Y); -NODES[271].Fix(VELOCITY_Z); -NODES[272].Fix(VELOCITY_X); -NODES[272].Fix(VELOCITY_Y); -NODES[272].Fix(VELOCITY_Z); -NODES[273].Fix(VELOCITY_X); -NODES[273].Fix(VELOCITY_Y); -NODES[273].Fix(VELOCITY_Z); -NODES[274].Fix(VELOCITY_X); -NODES[274].Fix(VELOCITY_Y); -NODES[274].Fix(VELOCITY_Z); -NODES[275].Fix(VELOCITY_X); -NODES[275].Fix(VELOCITY_Y); -NODES[275].Fix(VELOCITY_Z); -NODES[276].Fix(VELOCITY_X); -NODES[276].Fix(VELOCITY_Y); -NODES[276].Fix(VELOCITY_Z); -NODES[277].Fix(VELOCITY_X); -NODES[277].Fix(VELOCITY_Y); -NODES[277].Fix(VELOCITY_Z); -NODES[278].Fix(VELOCITY_X); -NODES[278].Fix(VELOCITY_Y); -NODES[278].Fix(VELOCITY_Z); -NODES[279].Fix(VELOCITY_X); -NODES[279].Fix(VELOCITY_Y); -NODES[279].Fix(VELOCITY_Z); -NODES[280].Fix(VELOCITY_X); -NODES[280].Fix(VELOCITY_Y); -NODES[280].Fix(VELOCITY_Z); -NODES[281].Fix(VELOCITY_X); -NODES[281].Fix(VELOCITY_Y); -NODES[281].Fix(VELOCITY_Z); -NODES[282].Fix(VELOCITY_X); -NODES[282].Fix(VELOCITY_Y); -NODES[282].Fix(VELOCITY_Z); -NODES[283].Fix(VELOCITY_X); -NODES[283].Fix(VELOCITY_Y); -NODES[283].Fix(VELOCITY_Z); -NODES[284].Fix(VELOCITY_X); -NODES[284].Fix(VELOCITY_Y); -NODES[284].Fix(VELOCITY_Z); -NODES[285].Fix(VELOCITY_X); -NODES[285].Fix(VELOCITY_Y); -NODES[285].Fix(VELOCITY_Z); -NODES[286].Fix(VELOCITY_X); -NODES[286].Fix(VELOCITY_Y); -NODES[286].Fix(VELOCITY_Z); -NODES[287].Fix(VELOCITY_X); -NODES[287].Fix(VELOCITY_Y); -NODES[287].Fix(VELOCITY_Z); -NODES[288].Fix(VELOCITY_X); -NODES[288].Fix(VELOCITY_Y); -NODES[288].Fix(VELOCITY_Z); -NODES[289].Fix(VELOCITY_X); -NODES[289].Fix(VELOCITY_Y); -NODES[289].Fix(VELOCITY_Z); -NODES[290].Fix(VELOCITY_X); -NODES[290].Fix(VELOCITY_Y); -NODES[290].Fix(VELOCITY_Z); -NODES[291].Fix(VELOCITY_X); -NODES[291].Fix(VELOCITY_Y); -NODES[291].Fix(VELOCITY_Z); -NODES[292].Fix(VELOCITY_X); -NODES[292].Fix(VELOCITY_Y); -NODES[292].Fix(VELOCITY_Z); -NODES[293].Fix(VELOCITY_X); -NODES[293].Fix(VELOCITY_Y); -NODES[293].Fix(VELOCITY_Z); -NODES[294].Fix(VELOCITY_X); -NODES[294].Fix(VELOCITY_Y); -NODES[294].Fix(VELOCITY_Z); -NODES[295].Fix(VELOCITY_X); -NODES[295].Fix(VELOCITY_Y); -NODES[295].Fix(VELOCITY_Z); -NODES[296].Fix(VELOCITY_X); -NODES[296].Fix(VELOCITY_Y); -NODES[296].Fix(VELOCITY_Z); -NODES[297].Fix(VELOCITY_X); -NODES[297].Fix(VELOCITY_Y); -NODES[297].Fix(VELOCITY_Z); -NODES[298].Fix(VELOCITY_X); -NODES[298].Fix(VELOCITY_Y); -NODES[298].Fix(VELOCITY_Z); -NODES[299].Fix(VELOCITY_X); -NODES[299].Fix(VELOCITY_Y); -NODES[299].Fix(VELOCITY_Z); -NODES[300].Fix(VELOCITY_X); -NODES[300].Fix(VELOCITY_Y); -NODES[300].Fix(VELOCITY_Z); -NODES[301].Fix(VELOCITY_X); -NODES[301].Fix(VELOCITY_Y); -NODES[301].Fix(VELOCITY_Z); -NODES[302].Fix(VELOCITY_X); -NODES[302].Fix(VELOCITY_Y); -NODES[302].Fix(VELOCITY_Z); -NODES[303].Fix(VELOCITY_X); -NODES[303].Fix(VELOCITY_Y); -NODES[303].Fix(VELOCITY_Z); -NODES[304].Fix(VELOCITY_X); -NODES[304].Fix(VELOCITY_Y); -NODES[304].Fix(VELOCITY_Z); -NODES[305].Fix(VELOCITY_X); -NODES[305].Fix(VELOCITY_Y); -NODES[305].Fix(VELOCITY_Z); -NODES[306].Fix(VELOCITY_X); -NODES[306].Fix(VELOCITY_Y); -NODES[306].Fix(VELOCITY_Z); -NODES[307].Fix(VELOCITY_X); -NODES[307].Fix(VELOCITY_Y); -NODES[307].Fix(VELOCITY_Z); -NODES[308].Fix(VELOCITY_X); -NODES[308].Fix(VELOCITY_Y); -NODES[308].Fix(VELOCITY_Z); -NODES[309].Fix(VELOCITY_X); -NODES[309].Fix(VELOCITY_Y); -NODES[309].Fix(VELOCITY_Z); -NODES[310].Fix(VELOCITY_X); -NODES[310].Fix(VELOCITY_Y); -NODES[310].Fix(VELOCITY_Z); -NODES[311].Fix(VELOCITY_X); -NODES[311].Fix(VELOCITY_Y); -NODES[311].Fix(VELOCITY_Z); -NODES[312].Fix(VELOCITY_X); -NODES[312].Fix(VELOCITY_Y); -NODES[312].Fix(VELOCITY_Z); -NODES[313].Fix(VELOCITY_X); -NODES[313].Fix(VELOCITY_Y); -NODES[313].Fix(VELOCITY_Z); -NODES[314].Fix(VELOCITY_X); -NODES[314].Fix(VELOCITY_Y); -NODES[314].Fix(VELOCITY_Z); -NODES[315].Fix(VELOCITY_X); -NODES[315].Fix(VELOCITY_Y); -NODES[315].Fix(VELOCITY_Z); -NODES[316].Fix(VELOCITY_X); -NODES[316].Fix(VELOCITY_Y); -NODES[316].Fix(VELOCITY_Z); -NODES[317].Fix(VELOCITY_X); -NODES[317].Fix(VELOCITY_Y); -NODES[317].Fix(VELOCITY_Z); -NODES[318].Fix(VELOCITY_X); -NODES[318].Fix(VELOCITY_Y); -NODES[318].Fix(VELOCITY_Z); -NODES[319].Fix(VELOCITY_X); -NODES[319].Fix(VELOCITY_Y); -NODES[319].Fix(VELOCITY_Z); -NODES[320].Fix(VELOCITY_X); -NODES[320].Fix(VELOCITY_Y); -NODES[320].Fix(VELOCITY_Z); -NODES[321].Fix(VELOCITY_X); -NODES[321].Fix(VELOCITY_Y); -NODES[321].Fix(VELOCITY_Z); -NODES[322].Fix(VELOCITY_X); -NODES[322].Fix(VELOCITY_Y); -NODES[322].Fix(VELOCITY_Z); -NODES[323].Fix(VELOCITY_X); -NODES[323].Fix(VELOCITY_Y); -NODES[323].Fix(VELOCITY_Z); -NODES[324].Fix(VELOCITY_X); -NODES[324].Fix(VELOCITY_Y); -NODES[324].Fix(VELOCITY_Z); -NODES[325].Fix(VELOCITY_X); -NODES[325].Fix(VELOCITY_Y); -NODES[325].Fix(VELOCITY_Z); -NODES[326].Fix(VELOCITY_X); -NODES[326].Fix(VELOCITY_Y); -NODES[326].Fix(VELOCITY_Z); -NODES[327].Fix(VELOCITY_X); -NODES[327].Fix(VELOCITY_Y); -NODES[327].Fix(VELOCITY_Z); -NODES[328].Fix(VELOCITY_X); -NODES[328].Fix(VELOCITY_Y); -NODES[328].Fix(VELOCITY_Z); -NODES[329].Fix(VELOCITY_X); -NODES[329].Fix(VELOCITY_Y); -NODES[329].Fix(VELOCITY_Z); -NODES[330].Fix(VELOCITY_X); -NODES[330].Fix(VELOCITY_Y); -NODES[330].Fix(VELOCITY_Z); -NODES[331].Fix(VELOCITY_X); -NODES[331].Fix(VELOCITY_Y); -NODES[331].Fix(VELOCITY_Z); -NODES[332].Fix(VELOCITY_X); -NODES[332].Fix(VELOCITY_Y); -NODES[332].Fix(VELOCITY_Z); -NODES[333].Fix(VELOCITY_X); -NODES[333].Fix(VELOCITY_Y); -NODES[333].Fix(VELOCITY_Z); -NODES[334].Fix(VELOCITY_X); -NODES[334].Fix(VELOCITY_Y); -NODES[334].Fix(VELOCITY_Z); -NODES[335].Fix(VELOCITY_X); -NODES[335].Fix(VELOCITY_Y); -NODES[335].Fix(VELOCITY_Z); -NODES[336].Fix(VELOCITY_X); -NODES[336].Fix(VELOCITY_Y); -NODES[336].Fix(VELOCITY_Z); -NODES[337].Fix(VELOCITY_X); -NODES[337].Fix(VELOCITY_Y); -NODES[337].Fix(VELOCITY_Z); -NODES[338].Fix(VELOCITY_X); -NODES[338].Fix(VELOCITY_Y); -NODES[338].Fix(VELOCITY_Z); -NODES[339].Fix(VELOCITY_X); -NODES[339].Fix(VELOCITY_Y); -NODES[339].Fix(VELOCITY_Z); -NODES[340].Fix(VELOCITY_X); -NODES[340].Fix(VELOCITY_Y); -NODES[340].Fix(VELOCITY_Z); -NODES[341].Fix(VELOCITY_X); -NODES[341].Fix(VELOCITY_Y); -NODES[341].Fix(VELOCITY_Z); -NODES[342].Fix(VELOCITY_X); -NODES[342].Fix(VELOCITY_Y); -NODES[342].Fix(VELOCITY_Z); -NODES[343].Fix(VELOCITY_X); -NODES[343].Fix(VELOCITY_Y); -NODES[343].Fix(VELOCITY_Z); -NODES[344].Fix(VELOCITY_X); -NODES[344].Fix(VELOCITY_Y); -NODES[344].Fix(VELOCITY_Z); -NODES[345].Fix(VELOCITY_X); -NODES[345].Fix(VELOCITY_Y); -NODES[345].Fix(VELOCITY_Z); -NODES[346].Fix(VELOCITY_X); -NODES[346].Fix(VELOCITY_Y); -NODES[346].Fix(VELOCITY_Z); -NODES[347].Fix(VELOCITY_X); -NODES[347].Fix(VELOCITY_Y); -NODES[347].Fix(VELOCITY_Z); -NODES[348].Fix(VELOCITY_X); -NODES[348].Fix(VELOCITY_Y); -NODES[348].Fix(VELOCITY_Z); -NODES[349].Fix(VELOCITY_X); -NODES[349].Fix(VELOCITY_Y); -NODES[349].Fix(VELOCITY_Z); -NODES[350].Fix(VELOCITY_X); -NODES[350].Fix(VELOCITY_Y); -NODES[350].Fix(VELOCITY_Z); -NODES[351].Fix(VELOCITY_X); -NODES[351].Fix(VELOCITY_Y); -NODES[351].Fix(VELOCITY_Z); -NODES[352].Fix(VELOCITY_X); -NODES[352].Fix(VELOCITY_Y); -NODES[352].Fix(VELOCITY_Z); -NODES[353].Fix(VELOCITY_X); -NODES[353].Fix(VELOCITY_Y); -NODES[353].Fix(VELOCITY_Z); -NODES[354].Fix(VELOCITY_X); -NODES[354].Fix(VELOCITY_Y); -NODES[354].Fix(VELOCITY_Z); -NODES[355].Fix(VELOCITY_X); -NODES[355].Fix(VELOCITY_Y); -NODES[355].Fix(VELOCITY_Z); -NODES[356].Fix(VELOCITY_X); -NODES[356].Fix(VELOCITY_Y); -NODES[356].Fix(VELOCITY_Z); -NODES[357].Fix(VELOCITY_X); -NODES[357].Fix(VELOCITY_Y); -NODES[357].Fix(VELOCITY_Z); -NODES[358].Fix(VELOCITY_X); -NODES[358].Fix(VELOCITY_Y); -NODES[358].Fix(VELOCITY_Z); -NODES[359].Fix(VELOCITY_X); -NODES[359].Fix(VELOCITY_Y); -NODES[359].Fix(VELOCITY_Z); -NODES[360].Fix(VELOCITY_X); -NODES[360].Fix(VELOCITY_Y); -NODES[360].Fix(VELOCITY_Z); -NODES[361].Fix(VELOCITY_X); -NODES[361].Fix(VELOCITY_Y); -NODES[361].Fix(VELOCITY_Z); -NODES[362].Fix(VELOCITY_X); -NODES[362].Fix(VELOCITY_Y); -NODES[362].Fix(VELOCITY_Z); -NODES[363].Fix(VELOCITY_X); -NODES[363].Fix(VELOCITY_Y); -NODES[363].Fix(VELOCITY_Z); -NODES[364].Fix(VELOCITY_X); -NODES[364].Fix(VELOCITY_Y); -NODES[364].Fix(VELOCITY_Z); -NODES[365].Fix(VELOCITY_X); -NODES[365].Fix(VELOCITY_Y); -NODES[365].Fix(VELOCITY_Z); -NODES[366].Fix(VELOCITY_X); -NODES[366].Fix(VELOCITY_Y); -NODES[366].Fix(VELOCITY_Z); -NODES[367].Fix(VELOCITY_X); -NODES[367].Fix(VELOCITY_Y); -NODES[367].Fix(VELOCITY_Z); -NODES[368].Fix(VELOCITY_X); -NODES[368].Fix(VELOCITY_Y); -NODES[368].Fix(VELOCITY_Z); -NODES[369].Fix(VELOCITY_X); -NODES[369].Fix(VELOCITY_Y); -NODES[369].Fix(VELOCITY_Z); -NODES[370].Fix(VELOCITY_X); -NODES[370].Fix(VELOCITY_Y); -NODES[370].Fix(VELOCITY_Z); -NODES[371].Fix(VELOCITY_X); -NODES[371].Fix(VELOCITY_Y); -NODES[371].Fix(VELOCITY_Z); -NODES[372].Fix(VELOCITY_X); -NODES[372].Fix(VELOCITY_Y); -NODES[372].Fix(VELOCITY_Z); -NODES[373].Fix(VELOCITY_X); -NODES[373].Fix(VELOCITY_Y); -NODES[373].Fix(VELOCITY_Z); -NODES[374].Fix(VELOCITY_X); -NODES[374].Fix(VELOCITY_Y); -NODES[374].Fix(VELOCITY_Z); -NODES[375].Fix(VELOCITY_X); -NODES[375].Fix(VELOCITY_Y); -NODES[375].Fix(VELOCITY_Z); -NODES[376].Fix(VELOCITY_X); -NODES[376].Fix(VELOCITY_Y); -NODES[376].Fix(VELOCITY_Z); -NODES[377].Fix(VELOCITY_X); -NODES[377].Fix(VELOCITY_Y); -NODES[377].Fix(VELOCITY_Z); -NODES[378].Fix(VELOCITY_X); -NODES[378].Fix(VELOCITY_Y); -NODES[378].Fix(VELOCITY_Z); -NODES[379].Fix(VELOCITY_X); -NODES[379].Fix(VELOCITY_Y); -NODES[379].Fix(VELOCITY_Z); -NODES[380].Fix(VELOCITY_X); -NODES[380].Fix(VELOCITY_Y); -NODES[380].Fix(VELOCITY_Z); -NODES[381].Fix(VELOCITY_X); -NODES[381].Fix(VELOCITY_Y); -NODES[381].Fix(VELOCITY_Z); -NODES[382].Fix(VELOCITY_X); -NODES[382].Fix(VELOCITY_Y); -NODES[382].Fix(VELOCITY_Z); -NODES[383].Fix(VELOCITY_X); -NODES[383].Fix(VELOCITY_Y); -NODES[383].Fix(VELOCITY_Z); -NODES[384].Fix(VELOCITY_X); -NODES[384].Fix(VELOCITY_Y); -NODES[384].Fix(VELOCITY_Z); -NODES[385].Fix(VELOCITY_X); -NODES[385].Fix(VELOCITY_Y); -NODES[385].Fix(VELOCITY_Z); -NODES[386].Fix(VELOCITY_X); -NODES[386].Fix(VELOCITY_Y); -NODES[386].Fix(VELOCITY_Z); -NODES[387].Fix(VELOCITY_X); -NODES[387].Fix(VELOCITY_Y); -NODES[387].Fix(VELOCITY_Z); -NODES[388].Fix(VELOCITY_X); -NODES[388].Fix(VELOCITY_Y); -NODES[388].Fix(VELOCITY_Z); -NODES[389].Fix(VELOCITY_X); -NODES[389].Fix(VELOCITY_Y); -NODES[389].Fix(VELOCITY_Z); -NODES[390].Fix(VELOCITY_X); -NODES[390].Fix(VELOCITY_Y); -NODES[390].Fix(VELOCITY_Z); -NODES[391].Fix(VELOCITY_X); -NODES[391].Fix(VELOCITY_Y); -NODES[391].Fix(VELOCITY_Z); -NODES[392].Fix(VELOCITY_X); -NODES[392].Fix(VELOCITY_Y); -NODES[392].Fix(VELOCITY_Z); -NODES[393].Fix(VELOCITY_X); -NODES[393].Fix(VELOCITY_Y); -NODES[393].Fix(VELOCITY_Z); -NODES[394].Fix(VELOCITY_X); -NODES[394].Fix(VELOCITY_Y); -NODES[394].Fix(VELOCITY_Z); -NODES[395].Fix(VELOCITY_X); -NODES[395].Fix(VELOCITY_Y); -NODES[395].Fix(VELOCITY_Z); -NODES[396].Fix(VELOCITY_X); -NODES[396].Fix(VELOCITY_Y); -NODES[396].Fix(VELOCITY_Z); -NODES[397].Fix(VELOCITY_X); -NODES[397].Fix(VELOCITY_Y); -NODES[397].Fix(VELOCITY_Z); -NODES[398].Fix(VELOCITY_X); -NODES[398].Fix(VELOCITY_Y); -NODES[398].Fix(VELOCITY_Z); -NODES[399].Fix(VELOCITY_X); -NODES[399].Fix(VELOCITY_Y); -NODES[399].Fix(VELOCITY_Z); -NODES[400].Fix(VELOCITY_X); -NODES[400].Fix(VELOCITY_Y); -NODES[400].Fix(VELOCITY_Z); -NODES[401].Fix(VELOCITY_X); -NODES[401].Fix(VELOCITY_Y); -NODES[401].Fix(VELOCITY_Z); -NODES[402].Fix(VELOCITY_X); -NODES[402].Fix(VELOCITY_Y); -NODES[402].Fix(VELOCITY_Z); -NODES[403].Fix(VELOCITY_X); -NODES[403].Fix(VELOCITY_Y); -NODES[403].Fix(VELOCITY_Z); -NODES[404].Fix(VELOCITY_X); -NODES[404].Fix(VELOCITY_Y); -NODES[404].Fix(VELOCITY_Z); -NODES[405].Fix(VELOCITY_X); -NODES[405].Fix(VELOCITY_Y); -NODES[405].Fix(VELOCITY_Z); -NODES[406].Fix(VELOCITY_X); -NODES[406].Fix(VELOCITY_Y); -NODES[406].Fix(VELOCITY_Z); -NODES[407].Fix(VELOCITY_X); -NODES[407].Fix(VELOCITY_Y); -NODES[407].Fix(VELOCITY_Z); -NODES[408].Fix(VELOCITY_X); -NODES[408].Fix(VELOCITY_Y); -NODES[408].Fix(VELOCITY_Z); -NODES[409].Fix(VELOCITY_X); -NODES[409].Fix(VELOCITY_Y); -NODES[409].Fix(VELOCITY_Z); -NODES[410].Fix(VELOCITY_X); -NODES[410].Fix(VELOCITY_Y); -NODES[410].Fix(VELOCITY_Z); -NODES[411].Fix(VELOCITY_X); -NODES[411].Fix(VELOCITY_Y); -NODES[411].Fix(VELOCITY_Z); -NODES[412].Fix(VELOCITY_X); -NODES[412].Fix(VELOCITY_Y); -NODES[412].Fix(VELOCITY_Z); -NODES[413].Fix(VELOCITY_X); -NODES[413].Fix(VELOCITY_Y); -NODES[413].Fix(VELOCITY_Z); -NODES[414].Fix(VELOCITY_X); -NODES[414].Fix(VELOCITY_Y); -NODES[414].Fix(VELOCITY_Z); -NODES[415].Fix(VELOCITY_X); -NODES[415].Fix(VELOCITY_Y); -NODES[415].Fix(VELOCITY_Z); -NODES[416].Fix(VELOCITY_X); -NODES[416].Fix(VELOCITY_Y); -NODES[416].Fix(VELOCITY_Z); -NODES[417].Fix(VELOCITY_X); -NODES[417].Fix(VELOCITY_Y); -NODES[417].Fix(VELOCITY_Z); -NODES[418].Fix(VELOCITY_X); -NODES[418].Fix(VELOCITY_Y); -NODES[418].Fix(VELOCITY_Z); -NODES[419].Fix(VELOCITY_X); -NODES[419].Fix(VELOCITY_Y); -NODES[419].Fix(VELOCITY_Z); -NODES[420].Fix(VELOCITY_X); -NODES[420].Fix(VELOCITY_Y); -NODES[420].Fix(VELOCITY_Z); -NODES[421].Fix(VELOCITY_X); -NODES[421].Fix(VELOCITY_Y); -NODES[421].Fix(VELOCITY_Z); -NODES[422].Fix(VELOCITY_X); -NODES[422].Fix(VELOCITY_Y); -NODES[422].Fix(VELOCITY_Z); -NODES[423].Fix(VELOCITY_X); -NODES[423].Fix(VELOCITY_Y); -NODES[423].Fix(VELOCITY_Z); -NODES[424].Fix(VELOCITY_X); -NODES[424].Fix(VELOCITY_Y); -NODES[424].Fix(VELOCITY_Z); -NODES[425].Fix(VELOCITY_X); -NODES[425].Fix(VELOCITY_Y); -NODES[425].Fix(VELOCITY_Z); -NODES[426].Fix(VELOCITY_X); -NODES[426].Fix(VELOCITY_Y); -NODES[426].Fix(VELOCITY_Z); -NODES[427].Fix(VELOCITY_X); -NODES[427].Fix(VELOCITY_Y); -NODES[427].Fix(VELOCITY_Z); -NODES[428].Fix(VELOCITY_X); -NODES[428].Fix(VELOCITY_Y); -NODES[428].Fix(VELOCITY_Z); -NODES[429].Fix(VELOCITY_X); -NODES[429].Fix(VELOCITY_Y); -NODES[429].Fix(VELOCITY_Z); -NODES[430].Fix(VELOCITY_X); -NODES[430].Fix(VELOCITY_Y); -NODES[430].Fix(VELOCITY_Z); -NODES[431].Fix(VELOCITY_X); -NODES[431].Fix(VELOCITY_Y); -NODES[431].Fix(VELOCITY_Z); -NODES[432].Fix(VELOCITY_X); -NODES[432].Fix(VELOCITY_Y); -NODES[432].Fix(VELOCITY_Z); -NODES[433].Fix(VELOCITY_X); -NODES[433].Fix(VELOCITY_Y); -NODES[433].Fix(VELOCITY_Z); -NODES[434].Fix(VELOCITY_X); -NODES[434].Fix(VELOCITY_Y); -NODES[434].Fix(VELOCITY_Z); -NODES[435].Fix(VELOCITY_X); -NODES[435].Fix(VELOCITY_Y); -NODES[435].Fix(VELOCITY_Z); -NODES[436].Fix(VELOCITY_X); -NODES[436].Fix(VELOCITY_Y); -NODES[436].Fix(VELOCITY_Z); -NODES[437].Fix(VELOCITY_X); -NODES[437].Fix(VELOCITY_Y); -NODES[437].Fix(VELOCITY_Z); -NODES[438].Fix(VELOCITY_X); -NODES[438].Fix(VELOCITY_Y); -NODES[438].Fix(VELOCITY_Z); -NODES[439].Fix(VELOCITY_X); -NODES[439].Fix(VELOCITY_Y); -NODES[439].Fix(VELOCITY_Z); -NODES[440].Fix(VELOCITY_X); -NODES[440].Fix(VELOCITY_Y); -NODES[440].Fix(VELOCITY_Z); -NODES[441].Fix(VELOCITY_X); -NODES[441].Fix(VELOCITY_Y); -NODES[441].Fix(VELOCITY_Z); -NODES[442].Fix(VELOCITY_X); -NODES[442].Fix(VELOCITY_Y); -NODES[442].Fix(VELOCITY_Z); -NODES[443].Fix(VELOCITY_X); -NODES[443].Fix(VELOCITY_Y); -NODES[443].Fix(VELOCITY_Z); -NODES[444].Fix(VELOCITY_X); -NODES[444].Fix(VELOCITY_Y); -NODES[444].Fix(VELOCITY_Z); -NODES[445].Fix(VELOCITY_X); -NODES[445].Fix(VELOCITY_Y); -NODES[445].Fix(VELOCITY_Z); -NODES[446].Fix(VELOCITY_X); -NODES[446].Fix(VELOCITY_Y); -NODES[446].Fix(VELOCITY_Z); -NODES[447].Fix(VELOCITY_X); -NODES[447].Fix(VELOCITY_Y); -NODES[447].Fix(VELOCITY_Z); -NODES[448].Fix(VELOCITY_X); -NODES[448].Fix(VELOCITY_Y); -NODES[448].Fix(VELOCITY_Z); -NODES[449].Fix(VELOCITY_X); -NODES[449].Fix(VELOCITY_Y); -NODES[449].Fix(VELOCITY_Z); -NODES[450].Fix(VELOCITY_X); -NODES[450].Fix(VELOCITY_Y); -NODES[450].Fix(VELOCITY_Z); -NODES[451].Fix(VELOCITY_X); -NODES[451].Fix(VELOCITY_Y); -NODES[451].Fix(VELOCITY_Z); -NODES[452].Fix(VELOCITY_X); -NODES[452].Fix(VELOCITY_Y); -NODES[452].Fix(VELOCITY_Z); -NODES[453].Fix(VELOCITY_X); -NODES[453].Fix(VELOCITY_Y); -NODES[453].Fix(VELOCITY_Z); -NODES[454].Fix(VELOCITY_X); -NODES[454].Fix(VELOCITY_Y); -NODES[454].Fix(VELOCITY_Z); -NODES[455].Fix(VELOCITY_X); -NODES[455].Fix(VELOCITY_Y); -NODES[455].Fix(VELOCITY_Z); -NODES[456].Fix(VELOCITY_X); -NODES[456].Fix(VELOCITY_Y); -NODES[456].Fix(VELOCITY_Z); -NODES[457].Fix(VELOCITY_X); -NODES[457].Fix(VELOCITY_Y); -NODES[457].Fix(VELOCITY_Z); -NODES[458].Fix(VELOCITY_X); -NODES[458].Fix(VELOCITY_Y); -NODES[458].Fix(VELOCITY_Z); -NODES[459].Fix(VELOCITY_X); -NODES[459].Fix(VELOCITY_Y); -NODES[459].Fix(VELOCITY_Z); -NODES[460].Fix(VELOCITY_X); -NODES[460].Fix(VELOCITY_Y); -NODES[460].Fix(VELOCITY_Z); -NODES[461].Fix(VELOCITY_X); -NODES[461].Fix(VELOCITY_Y); -NODES[461].Fix(VELOCITY_Z); -NODES[462].Fix(VELOCITY_X); -NODES[462].Fix(VELOCITY_Y); -NODES[462].Fix(VELOCITY_Z); -NODES[463].Fix(VELOCITY_X); -NODES[463].Fix(VELOCITY_Y); -NODES[463].Fix(VELOCITY_Z); -NODES[464].Fix(VELOCITY_X); -NODES[464].Fix(VELOCITY_Y); -NODES[464].Fix(VELOCITY_Z); -NODES[465].Fix(VELOCITY_X); -NODES[465].Fix(VELOCITY_Y); -NODES[465].Fix(VELOCITY_Z); -NODES[466].Fix(VELOCITY_X); -NODES[466].Fix(VELOCITY_Y); -NODES[466].Fix(VELOCITY_Z); -NODES[467].Fix(VELOCITY_X); -NODES[467].Fix(VELOCITY_Y); -NODES[467].Fix(VELOCITY_Z); -NODES[468].Fix(VELOCITY_X); -NODES[468].Fix(VELOCITY_Y); -NODES[468].Fix(VELOCITY_Z); -NODES[469].Fix(VELOCITY_X); -NODES[469].Fix(VELOCITY_Y); -NODES[469].Fix(VELOCITY_Z); -NODES[470].Fix(VELOCITY_X); -NODES[470].Fix(VELOCITY_Y); -NODES[470].Fix(VELOCITY_Z); -NODES[471].Fix(VELOCITY_X); -NODES[471].Fix(VELOCITY_Y); -NODES[471].Fix(VELOCITY_Z); -NODES[472].Fix(VELOCITY_X); -NODES[472].Fix(VELOCITY_Y); -NODES[472].Fix(VELOCITY_Z); -NODES[473].Fix(VELOCITY_X); -NODES[473].Fix(VELOCITY_Y); -NODES[473].Fix(VELOCITY_Z); -NODES[474].Fix(VELOCITY_X); -NODES[474].Fix(VELOCITY_Y); -NODES[474].Fix(VELOCITY_Z); -NODES[475].Fix(VELOCITY_X); -NODES[475].Fix(VELOCITY_Y); -NODES[475].Fix(VELOCITY_Z); -NODES[476].Fix(VELOCITY_X); -NODES[476].Fix(VELOCITY_Y); -NODES[476].Fix(VELOCITY_Z); -NODES[477].Fix(VELOCITY_X); -NODES[477].Fix(VELOCITY_Y); -NODES[477].Fix(VELOCITY_Z); -NODES[478].Fix(VELOCITY_X); -NODES[478].Fix(VELOCITY_Y); -NODES[478].Fix(VELOCITY_Z); -NODES[479].Fix(VELOCITY_X); -NODES[479].Fix(VELOCITY_Y); -NODES[479].Fix(VELOCITY_Z); -NODES[480].Fix(VELOCITY_X); -NODES[480].Fix(VELOCITY_Y); -NODES[480].Fix(VELOCITY_Z); -NODES[481].Fix(VELOCITY_X); -NODES[481].Fix(VELOCITY_Y); -NODES[481].Fix(VELOCITY_Z); -NODES[482].Fix(VELOCITY_X); -NODES[482].Fix(VELOCITY_Y); -NODES[482].Fix(VELOCITY_Z); -NODES[483].Fix(VELOCITY_X); -NODES[483].Fix(VELOCITY_Y); -NODES[483].Fix(VELOCITY_Z); -NODES[484].Fix(VELOCITY_X); -NODES[484].Fix(VELOCITY_Y); -NODES[484].Fix(VELOCITY_Z); -NODES[485].Fix(VELOCITY_X); -NODES[485].Fix(VELOCITY_Y); -NODES[485].Fix(VELOCITY_Z); -NODES[486].Fix(VELOCITY_X); -NODES[486].Fix(VELOCITY_Y); -NODES[486].Fix(VELOCITY_Z); -NODES[487].Fix(VELOCITY_X); -NODES[487].Fix(VELOCITY_Y); -NODES[487].Fix(VELOCITY_Z); -NODES[488].Fix(VELOCITY_X); -NODES[488].Fix(VELOCITY_Y); -NODES[488].Fix(VELOCITY_Z); -NODES[489].Fix(VELOCITY_X); -NODES[489].Fix(VELOCITY_Y); -NODES[489].Fix(VELOCITY_Z); -NODES[490].Fix(VELOCITY_X); -NODES[490].Fix(VELOCITY_Y); -NODES[490].Fix(VELOCITY_Z); -NODES[491].Fix(VELOCITY_X); -NODES[491].Fix(VELOCITY_Y); -NODES[491].Fix(VELOCITY_Z); -NODES[492].Fix(VELOCITY_X); -NODES[492].Fix(VELOCITY_Y); -NODES[492].Fix(VELOCITY_Z); -NODES[493].Fix(VELOCITY_X); -NODES[493].Fix(VELOCITY_Y); -NODES[493].Fix(VELOCITY_Z); -NODES[494].Fix(VELOCITY_X); -NODES[494].Fix(VELOCITY_Y); -NODES[494].Fix(VELOCITY_Z); -NODES[495].Fix(VELOCITY_X); -NODES[495].Fix(VELOCITY_Y); -NODES[495].Fix(VELOCITY_Z); -NODES[496].Fix(VELOCITY_X); -NODES[496].Fix(VELOCITY_Y); -NODES[496].Fix(VELOCITY_Z); -NODES[497].Fix(VELOCITY_X); -NODES[497].Fix(VELOCITY_Y); -NODES[497].Fix(VELOCITY_Z); -NODES[498].Fix(VELOCITY_X); -NODES[498].Fix(VELOCITY_Y); -NODES[498].Fix(VELOCITY_Z); -NODES[499].Fix(VELOCITY_X); -NODES[499].Fix(VELOCITY_Y); -NODES[499].Fix(VELOCITY_Z); -NODES[500].Fix(VELOCITY_X); -NODES[500].Fix(VELOCITY_Y); -NODES[500].Fix(VELOCITY_Z); -NODES[501].Fix(VELOCITY_X); -NODES[501].Fix(VELOCITY_Y); -NODES[501].Fix(VELOCITY_Z); -NODES[502].Fix(VELOCITY_X); -NODES[502].Fix(VELOCITY_Y); -NODES[502].Fix(VELOCITY_Z); -NODES[503].Fix(VELOCITY_X); -NODES[503].Fix(VELOCITY_Y); -NODES[503].Fix(VELOCITY_Z); -NODES[504].Fix(VELOCITY_X); -NODES[504].Fix(VELOCITY_Y); -NODES[504].Fix(VELOCITY_Z); -NODES[505].Fix(VELOCITY_X); -NODES[505].Fix(VELOCITY_Y); -NODES[505].Fix(VELOCITY_Z); -NODES[506].Fix(VELOCITY_X); -NODES[506].Fix(VELOCITY_Y); -NODES[506].Fix(VELOCITY_Z); -NODES[507].Fix(VELOCITY_X); -NODES[507].Fix(VELOCITY_Y); -NODES[507].Fix(VELOCITY_Z); -NODES[508].Fix(VELOCITY_X); -NODES[508].Fix(VELOCITY_Y); -NODES[508].Fix(VELOCITY_Z); -NODES[509].Fix(VELOCITY_X); -NODES[509].Fix(VELOCITY_Y); -NODES[509].Fix(VELOCITY_Z); -NODES[510].Fix(VELOCITY_X); -NODES[510].Fix(VELOCITY_Y); -NODES[510].Fix(VELOCITY_Z); -NODES[511].Fix(VELOCITY_X); -NODES[511].Fix(VELOCITY_Y); -NODES[511].Fix(VELOCITY_Z); -NODES[512].Fix(VELOCITY_X); -NODES[512].Fix(VELOCITY_Y); -NODES[512].Fix(VELOCITY_Z); -NODES[513].Fix(VELOCITY_X); -NODES[513].Fix(VELOCITY_Y); -NODES[513].Fix(VELOCITY_Z); -NODES[514].Fix(VELOCITY_X); -NODES[514].Fix(VELOCITY_Y); -NODES[514].Fix(VELOCITY_Z); -NODES[515].Fix(VELOCITY_X); -NODES[515].Fix(VELOCITY_Y); -NODES[515].Fix(VELOCITY_Z); -NODES[516].Fix(VELOCITY_X); -NODES[516].Fix(VELOCITY_Y); -NODES[516].Fix(VELOCITY_Z); -NODES[517].Fix(VELOCITY_X); -NODES[517].Fix(VELOCITY_Y); -NODES[517].Fix(VELOCITY_Z); -NODES[518].Fix(VELOCITY_X); -NODES[518].Fix(VELOCITY_Y); -NODES[518].Fix(VELOCITY_Z); -NODES[519].Fix(VELOCITY_X); -NODES[519].Fix(VELOCITY_Y); -NODES[519].Fix(VELOCITY_Z); -NODES[520].Fix(VELOCITY_X); -NODES[520].Fix(VELOCITY_Y); -NODES[520].Fix(VELOCITY_Z); -NODES[521].Fix(VELOCITY_X); -NODES[521].Fix(VELOCITY_Y); -NODES[521].Fix(VELOCITY_Z); -NODES[522].Fix(VELOCITY_X); -NODES[522].Fix(VELOCITY_Y); -NODES[522].Fix(VELOCITY_Z); -NODES[523].Fix(VELOCITY_X); -NODES[523].Fix(VELOCITY_Y); -NODES[523].Fix(VELOCITY_Z); -NODES[524].Fix(VELOCITY_X); -NODES[524].Fix(VELOCITY_Y); -NODES[524].Fix(VELOCITY_Z); -NODES[525].Fix(VELOCITY_X); -NODES[525].Fix(VELOCITY_Y); -NODES[525].Fix(VELOCITY_Z); -NODES[526].Fix(VELOCITY_X); -NODES[526].Fix(VELOCITY_Y); -NODES[526].Fix(VELOCITY_Z); -NODES[527].Fix(VELOCITY_X); -NODES[527].Fix(VELOCITY_Y); -NODES[527].Fix(VELOCITY_Z); -NODES[528].Fix(VELOCITY_X); -NODES[528].Fix(VELOCITY_Y); -NODES[528].Fix(VELOCITY_Z); -NODES[529].Fix(VELOCITY_X); -NODES[529].Fix(VELOCITY_Y); -NODES[529].Fix(VELOCITY_Z); -NODES[530].Fix(VELOCITY_X); -NODES[530].Fix(VELOCITY_Y); -NODES[530].Fix(VELOCITY_Z); -NODES[531].Fix(VELOCITY_X); -NODES[531].Fix(VELOCITY_Y); -NODES[531].Fix(VELOCITY_Z); -NODES[532].Fix(VELOCITY_X); -NODES[532].Fix(VELOCITY_Y); -NODES[532].Fix(VELOCITY_Z); -NODES[533].Fix(VELOCITY_X); -NODES[533].Fix(VELOCITY_Y); -NODES[533].Fix(VELOCITY_Z); -NODES[534].Fix(VELOCITY_X); -NODES[534].Fix(VELOCITY_Y); -NODES[534].Fix(VELOCITY_Z); -NODES[535].Fix(VELOCITY_X); -NODES[535].Fix(VELOCITY_Y); -NODES[535].Fix(VELOCITY_Z); -NODES[536].Fix(VELOCITY_X); -NODES[536].Fix(VELOCITY_Y); -NODES[536].Fix(VELOCITY_Z); -NODES[537].Fix(VELOCITY_X); -NODES[537].Fix(VELOCITY_Y); -NODES[537].Fix(VELOCITY_Z); -NODES[538].Fix(VELOCITY_X); -NODES[538].Fix(VELOCITY_Y); -NODES[538].Fix(VELOCITY_Z); -NODES[539].Fix(VELOCITY_X); -NODES[539].Fix(VELOCITY_Y); -NODES[539].Fix(VELOCITY_Z); -NODES[540].Fix(VELOCITY_X); -NODES[540].Fix(VELOCITY_Y); -NODES[540].Fix(VELOCITY_Z); -NODES[541].Fix(VELOCITY_X); -NODES[541].Fix(VELOCITY_Y); -NODES[541].Fix(VELOCITY_Z); -NODES[542].Fix(VELOCITY_X); -NODES[542].Fix(VELOCITY_Y); -NODES[542].Fix(VELOCITY_Z); -NODES[543].Fix(VELOCITY_X); -NODES[543].Fix(VELOCITY_Y); -NODES[543].Fix(VELOCITY_Z); -NODES[544].Fix(VELOCITY_X); -NODES[544].Fix(VELOCITY_Y); -NODES[544].Fix(VELOCITY_Z); -NODES[545].Fix(VELOCITY_X); -NODES[545].Fix(VELOCITY_Y); -NODES[545].Fix(VELOCITY_Z); -NODES[546].Fix(VELOCITY_X); -NODES[546].Fix(VELOCITY_Y); -NODES[546].Fix(VELOCITY_Z); -NODES[547].Fix(VELOCITY_X); -NODES[547].Fix(VELOCITY_Y); -NODES[547].Fix(VELOCITY_Z); -NODES[548].Fix(VELOCITY_X); -NODES[548].Fix(VELOCITY_Y); -NODES[548].Fix(VELOCITY_Z); -NODES[549].Fix(VELOCITY_X); -NODES[549].Fix(VELOCITY_Y); -NODES[549].Fix(VELOCITY_Z); -NODES[550].Fix(VELOCITY_X); -NODES[550].Fix(VELOCITY_Y); -NODES[550].Fix(VELOCITY_Z); -NODES[551].Fix(VELOCITY_X); -NODES[551].Fix(VELOCITY_Y); -NODES[551].Fix(VELOCITY_Z); -NODES[552].Fix(VELOCITY_X); -NODES[552].Fix(VELOCITY_Y); -NODES[552].Fix(VELOCITY_Z); -NODES[553].Fix(VELOCITY_X); -NODES[553].Fix(VELOCITY_Y); -NODES[553].Fix(VELOCITY_Z); -NODES[554].Fix(VELOCITY_X); -NODES[554].Fix(VELOCITY_Y); -NODES[554].Fix(VELOCITY_Z); -NODES[555].Fix(VELOCITY_X); -NODES[555].Fix(VELOCITY_Y); -NODES[555].Fix(VELOCITY_Z); -NODES[556].Fix(VELOCITY_X); -NODES[556].Fix(VELOCITY_Y); -NODES[556].Fix(VELOCITY_Z); -NODES[557].Fix(VELOCITY_X); -NODES[557].Fix(VELOCITY_Y); -NODES[557].Fix(VELOCITY_Z); -NODES[558].Fix(VELOCITY_X); -NODES[558].Fix(VELOCITY_Y); -NODES[558].Fix(VELOCITY_Z); -NODES[559].Fix(VELOCITY_X); -NODES[559].Fix(VELOCITY_Y); -NODES[559].Fix(VELOCITY_Z); -NODES[560].Fix(VELOCITY_X); -NODES[560].Fix(VELOCITY_Y); -NODES[560].Fix(VELOCITY_Z); -NODES[561].Fix(VELOCITY_X); -NODES[561].Fix(VELOCITY_Y); -NODES[561].Fix(VELOCITY_Z); -NODES[562].Fix(VELOCITY_X); -NODES[562].Fix(VELOCITY_Y); -NODES[562].Fix(VELOCITY_Z); -NODES[563].Fix(VELOCITY_X); -NODES[563].Fix(VELOCITY_Y); -NODES[563].Fix(VELOCITY_Z); -NODES[564].Fix(VELOCITY_X); -NODES[564].Fix(VELOCITY_Y); -NODES[564].Fix(VELOCITY_Z); -NODES[565].Fix(VELOCITY_X); -NODES[565].Fix(VELOCITY_Y); -NODES[565].Fix(VELOCITY_Z); -NODES[566].Fix(VELOCITY_X); -NODES[566].Fix(VELOCITY_Y); -NODES[566].Fix(VELOCITY_Z); -NODES[567].Fix(VELOCITY_X); -NODES[567].Fix(VELOCITY_Y); -NODES[567].Fix(VELOCITY_Z); -NODES[568].Fix(VELOCITY_X); -NODES[568].Fix(VELOCITY_Y); -NODES[568].Fix(VELOCITY_Z); -NODES[569].Fix(VELOCITY_X); -NODES[569].Fix(VELOCITY_Y); -NODES[569].Fix(VELOCITY_Z); -NODES[570].Fix(VELOCITY_X); -NODES[570].Fix(VELOCITY_Y); -NODES[570].Fix(VELOCITY_Z); -NODES[571].Fix(VELOCITY_X); -NODES[571].Fix(VELOCITY_Y); -NODES[571].Fix(VELOCITY_Z); -NODES[572].Fix(VELOCITY_X); -NODES[572].Fix(VELOCITY_Y); -NODES[572].Fix(VELOCITY_Z); -NODES[573].Fix(VELOCITY_X); -NODES[573].Fix(VELOCITY_Y); -NODES[573].Fix(VELOCITY_Z); -NODES[574].Fix(VELOCITY_X); -NODES[574].Fix(VELOCITY_Y); -NODES[574].Fix(VELOCITY_Z); -NODES[575].Fix(VELOCITY_X); -NODES[575].Fix(VELOCITY_Y); -NODES[575].Fix(VELOCITY_Z); -NODES[576].Fix(VELOCITY_X); -NODES[576].Fix(VELOCITY_Y); -NODES[576].Fix(VELOCITY_Z); -NODES[577].Fix(VELOCITY_X); -NODES[577].Fix(VELOCITY_Y); -NODES[577].Fix(VELOCITY_Z); -NODES[578].Fix(VELOCITY_X); -NODES[578].Fix(VELOCITY_Y); -NODES[578].Fix(VELOCITY_Z); -NODES[579].Fix(VELOCITY_X); -NODES[579].Fix(VELOCITY_Y); -NODES[579].Fix(VELOCITY_Z); -NODES[580].Fix(VELOCITY_X); -NODES[580].Fix(VELOCITY_Y); -NODES[580].Fix(VELOCITY_Z); -NODES[581].Fix(VELOCITY_X); -NODES[581].Fix(VELOCITY_Y); -NODES[581].Fix(VELOCITY_Z); -NODES[582].Fix(VELOCITY_X); -NODES[582].Fix(VELOCITY_Y); -NODES[582].Fix(VELOCITY_Z); -NODES[583].Fix(VELOCITY_X); -NODES[583].Fix(VELOCITY_Y); -NODES[583].Fix(VELOCITY_Z); -NODES[584].Fix(VELOCITY_X); -NODES[584].Fix(VELOCITY_Y); -NODES[584].Fix(VELOCITY_Z); -NODES[585].Fix(VELOCITY_X); -NODES[585].Fix(VELOCITY_Y); -NODES[585].Fix(VELOCITY_Z); -NODES[586].Fix(VELOCITY_X); -NODES[586].Fix(VELOCITY_Y); -NODES[586].Fix(VELOCITY_Z); -NODES[587].Fix(VELOCITY_X); -NODES[587].Fix(VELOCITY_Y); -NODES[587].Fix(VELOCITY_Z); -NODES[588].Fix(VELOCITY_X); -NODES[588].Fix(VELOCITY_Y); -NODES[588].Fix(VELOCITY_Z); -NODES[589].Fix(VELOCITY_X); -NODES[589].Fix(VELOCITY_Y); -NODES[589].Fix(VELOCITY_Z); -NODES[590].Fix(VELOCITY_X); -NODES[590].Fix(VELOCITY_Y); -NODES[590].Fix(VELOCITY_Z); -NODES[591].Fix(VELOCITY_X); -NODES[591].Fix(VELOCITY_Y); -NODES[591].Fix(VELOCITY_Z); -NODES[592].Fix(VELOCITY_X); -NODES[592].Fix(VELOCITY_Y); -NODES[592].Fix(VELOCITY_Z); -NODES[593].Fix(VELOCITY_X); -NODES[593].Fix(VELOCITY_Y); -NODES[593].Fix(VELOCITY_Z); -NODES[594].Fix(VELOCITY_X); -NODES[594].Fix(VELOCITY_Y); -NODES[594].Fix(VELOCITY_Z); -NODES[595].Fix(VELOCITY_X); -NODES[595].Fix(VELOCITY_Y); -NODES[595].Fix(VELOCITY_Z); -NODES[596].Fix(VELOCITY_X); -NODES[596].Fix(VELOCITY_Y); -NODES[596].Fix(VELOCITY_Z); -NODES[597].Fix(VELOCITY_X); -NODES[597].Fix(VELOCITY_Y); -NODES[597].Fix(VELOCITY_Z); -NODES[598].Fix(VELOCITY_X); -NODES[598].Fix(VELOCITY_Y); -NODES[598].Fix(VELOCITY_Z); -NODES[599].Fix(VELOCITY_X); -NODES[599].Fix(VELOCITY_Y); -NODES[599].Fix(VELOCITY_Z); -NODES[600].Fix(VELOCITY_X); -NODES[600].Fix(VELOCITY_Y); -NODES[600].Fix(VELOCITY_Z); -NODES[601].Fix(VELOCITY_X); -NODES[601].Fix(VELOCITY_Y); -NODES[601].Fix(VELOCITY_Z); -NODES[602].Fix(VELOCITY_X); -NODES[602].Fix(VELOCITY_Y); -NODES[602].Fix(VELOCITY_Z); -NODES[603].Fix(VELOCITY_X); -NODES[603].Fix(VELOCITY_Y); -NODES[603].Fix(VELOCITY_Z); -NODES[604].Fix(VELOCITY_X); -NODES[604].Fix(VELOCITY_Y); -NODES[604].Fix(VELOCITY_Z); -NODES[605].Fix(VELOCITY_X); -NODES[605].Fix(VELOCITY_Y); -NODES[605].Fix(VELOCITY_Z); -NODES[606].Fix(VELOCITY_X); -NODES[606].Fix(VELOCITY_Y); -NODES[606].Fix(VELOCITY_Z); -NODES[607].Fix(VELOCITY_X); -NODES[607].Fix(VELOCITY_Y); -NODES[607].Fix(VELOCITY_Z); -NODES[608].Fix(VELOCITY_X); -NODES[608].Fix(VELOCITY_Y); -NODES[608].Fix(VELOCITY_Z); -NODES[609].Fix(VELOCITY_X); -NODES[609].Fix(VELOCITY_Y); -NODES[609].Fix(VELOCITY_Z); -NODES[610].Fix(VELOCITY_X); -NODES[610].Fix(VELOCITY_Y); -NODES[610].Fix(VELOCITY_Z); -NODES[611].Fix(VELOCITY_X); -NODES[611].Fix(VELOCITY_Y); -NODES[611].Fix(VELOCITY_Z); -NODES[612].Fix(VELOCITY_X); -NODES[612].Fix(VELOCITY_Y); -NODES[612].Fix(VELOCITY_Z); -NODES[613].Fix(VELOCITY_X); -NODES[613].Fix(VELOCITY_Y); -NODES[613].Fix(VELOCITY_Z); -NODES[614].Fix(VELOCITY_X); -NODES[614].Fix(VELOCITY_Y); -NODES[614].Fix(VELOCITY_Z); -NODES[615].Fix(VELOCITY_X); -NODES[615].Fix(VELOCITY_Y); -NODES[615].Fix(VELOCITY_Z); -NODES[616].Fix(VELOCITY_X); -NODES[616].Fix(VELOCITY_Y); -NODES[616].Fix(VELOCITY_Z); -NODES[617].Fix(VELOCITY_X); -NODES[617].Fix(VELOCITY_Y); -NODES[617].Fix(VELOCITY_Z); -NODES[618].Fix(VELOCITY_X); -NODES[618].Fix(VELOCITY_Y); -NODES[618].Fix(VELOCITY_Z); -NODES[619].Fix(VELOCITY_X); -NODES[619].Fix(VELOCITY_Y); -NODES[619].Fix(VELOCITY_Z); -NODES[620].Fix(VELOCITY_X); -NODES[620].Fix(VELOCITY_Y); -NODES[620].Fix(VELOCITY_Z); -NODES[621].Fix(VELOCITY_X); -NODES[621].Fix(VELOCITY_Y); -NODES[621].Fix(VELOCITY_Z); -NODES[622].Fix(VELOCITY_X); -NODES[622].Fix(VELOCITY_Y); -NODES[622].Fix(VELOCITY_Z); -NODES[623].Fix(VELOCITY_X); -NODES[623].Fix(VELOCITY_Y); -NODES[623].Fix(VELOCITY_Z); -NODES[624].Fix(VELOCITY_X); -NODES[624].Fix(VELOCITY_Y); -NODES[624].Fix(VELOCITY_Z); -NODES[625].Fix(VELOCITY_X); -NODES[625].Fix(VELOCITY_Y); -NODES[625].Fix(VELOCITY_Z); -NODES[626].Fix(VELOCITY_X); -NODES[626].Fix(VELOCITY_Y); -NODES[626].Fix(VELOCITY_Z); -NODES[627].Fix(VELOCITY_X); -NODES[627].Fix(VELOCITY_Y); -NODES[627].Fix(VELOCITY_Z); -NODES[628].Fix(VELOCITY_X); -NODES[628].Fix(VELOCITY_Y); -NODES[628].Fix(VELOCITY_Z); -NODES[629].Fix(VELOCITY_X); -NODES[629].Fix(VELOCITY_Y); -NODES[629].Fix(VELOCITY_Z); -NODES[630].Fix(VELOCITY_X); -NODES[630].Fix(VELOCITY_Y); -NODES[630].Fix(VELOCITY_Z); -NODES[631].Fix(VELOCITY_X); -NODES[631].Fix(VELOCITY_Y); -NODES[631].Fix(VELOCITY_Z); -NODES[632].Fix(VELOCITY_X); -NODES[632].Fix(VELOCITY_Y); -NODES[632].Fix(VELOCITY_Z); -NODES[633].Fix(VELOCITY_X); -NODES[633].Fix(VELOCITY_Y); -NODES[633].Fix(VELOCITY_Z); -NODES[634].Fix(VELOCITY_X); -NODES[634].Fix(VELOCITY_Y); -NODES[634].Fix(VELOCITY_Z); -NODES[635].Fix(VELOCITY_X); -NODES[635].Fix(VELOCITY_Y); -NODES[635].Fix(VELOCITY_Z); -NODES[636].Fix(VELOCITY_X); -NODES[636].Fix(VELOCITY_Y); -NODES[636].Fix(VELOCITY_Z); -NODES[637].Fix(VELOCITY_X); -NODES[637].Fix(VELOCITY_Y); -NODES[637].Fix(VELOCITY_Z); -NODES[638].Fix(VELOCITY_X); -NODES[638].Fix(VELOCITY_Y); -NODES[638].Fix(VELOCITY_Z); -NODES[639].Fix(VELOCITY_X); -NODES[639].Fix(VELOCITY_Y); -NODES[639].Fix(VELOCITY_Z); -NODES[640].Fix(VELOCITY_X); -NODES[640].Fix(VELOCITY_Y); -NODES[640].Fix(VELOCITY_Z); -NODES[641].Fix(VELOCITY_X); -NODES[641].Fix(VELOCITY_Y); -NODES[641].Fix(VELOCITY_Z); -NODES[642].Fix(VELOCITY_X); -NODES[642].Fix(VELOCITY_Y); -NODES[642].Fix(VELOCITY_Z); -NODES[643].Fix(VELOCITY_X); -NODES[643].Fix(VELOCITY_Y); -NODES[643].Fix(VELOCITY_Z); -NODES[644].Fix(VELOCITY_X); -NODES[644].Fix(VELOCITY_Y); -NODES[644].Fix(VELOCITY_Z); -NODES[645].Fix(VELOCITY_X); -NODES[645].Fix(VELOCITY_Y); -NODES[645].Fix(VELOCITY_Z); -NODES[646].Fix(VELOCITY_X); -NODES[646].Fix(VELOCITY_Y); -NODES[646].Fix(VELOCITY_Z); -NODES[647].Fix(VELOCITY_X); -NODES[647].Fix(VELOCITY_Y); -NODES[647].Fix(VELOCITY_Z); -NODES[648].Fix(VELOCITY_X); -NODES[648].Fix(VELOCITY_Y); -NODES[648].Fix(VELOCITY_Z); -NODES[649].Fix(VELOCITY_X); -NODES[649].Fix(VELOCITY_Y); -NODES[649].Fix(VELOCITY_Z); -NODES[650].Fix(VELOCITY_X); -NODES[650].Fix(VELOCITY_Y); -NODES[650].Fix(VELOCITY_Z); -NODES[651].Fix(VELOCITY_X); -NODES[651].Fix(VELOCITY_Y); -NODES[651].Fix(VELOCITY_Z); -NODES[652].Fix(VELOCITY_X); -NODES[652].Fix(VELOCITY_Y); -NODES[652].Fix(VELOCITY_Z); -NODES[653].Fix(VELOCITY_X); -NODES[653].Fix(VELOCITY_Y); -NODES[653].Fix(VELOCITY_Z); -NODES[654].Fix(VELOCITY_X); -NODES[654].Fix(VELOCITY_Y); -NODES[654].Fix(VELOCITY_Z); -NODES[655].Fix(VELOCITY_X); -NODES[655].Fix(VELOCITY_Y); -NODES[655].Fix(VELOCITY_Z); -NODES[656].Fix(VELOCITY_X); -NODES[656].Fix(VELOCITY_Y); -NODES[656].Fix(VELOCITY_Z); -NODES[657].Fix(VELOCITY_X); -NODES[657].Fix(VELOCITY_Y); -NODES[657].Fix(VELOCITY_Z); -NODES[658].Fix(VELOCITY_X); -NODES[658].Fix(VELOCITY_Y); -NODES[658].Fix(VELOCITY_Z); -NODES[659].Fix(VELOCITY_X); -NODES[659].Fix(VELOCITY_Y); -NODES[659].Fix(VELOCITY_Z); -NODES[660].Fix(VELOCITY_X); -NODES[660].Fix(VELOCITY_Y); -NODES[660].Fix(VELOCITY_Z); -NODES[661].Fix(VELOCITY_X); -NODES[661].Fix(VELOCITY_Y); -NODES[661].Fix(VELOCITY_Z); -NODES[662].Fix(VELOCITY_X); -NODES[662].Fix(VELOCITY_Y); -NODES[662].Fix(VELOCITY_Z); -NODES[663].Fix(VELOCITY_X); -NODES[663].Fix(VELOCITY_Y); -NODES[663].Fix(VELOCITY_Z); -NODES[664].Fix(VELOCITY_X); -NODES[664].Fix(VELOCITY_Y); -NODES[664].Fix(VELOCITY_Z); -NODES[665].Fix(VELOCITY_X); -NODES[665].Fix(VELOCITY_Y); -NODES[665].Fix(VELOCITY_Z); -NODES[666].Fix(VELOCITY_X); -NODES[666].Fix(VELOCITY_Y); -NODES[666].Fix(VELOCITY_Z); -NODES[667].Fix(VELOCITY_X); -NODES[667].Fix(VELOCITY_Y); -NODES[667].Fix(VELOCITY_Z); -NODES[668].Fix(VELOCITY_X); -NODES[668].Fix(VELOCITY_Y); -NODES[668].Fix(VELOCITY_Z); -NODES[669].Fix(VELOCITY_X); -NODES[669].Fix(VELOCITY_Y); -NODES[669].Fix(VELOCITY_Z); -NODES[670].Fix(VELOCITY_X); -NODES[670].Fix(VELOCITY_Y); -NODES[670].Fix(VELOCITY_Z); -NODES[671].Fix(VELOCITY_X); -NODES[671].Fix(VELOCITY_Y); -NODES[671].Fix(VELOCITY_Z); -NODES[672].Fix(VELOCITY_X); -NODES[672].Fix(VELOCITY_Y); -NODES[672].Fix(VELOCITY_Z); -NODES[673].Fix(VELOCITY_X); -NODES[673].Fix(VELOCITY_Y); -NODES[673].Fix(VELOCITY_Z); -NODES[674].Fix(VELOCITY_X); -NODES[674].Fix(VELOCITY_Y); -NODES[674].Fix(VELOCITY_Z); -NODES[675].Fix(VELOCITY_X); -NODES[675].Fix(VELOCITY_Y); -NODES[675].Fix(VELOCITY_Z); -NODES[676].Fix(VELOCITY_X); -NODES[676].Fix(VELOCITY_Y); -NODES[676].Fix(VELOCITY_Z); -NODES[677].Fix(VELOCITY_X); -NODES[677].Fix(VELOCITY_Y); -NODES[677].Fix(VELOCITY_Z); -NODES[678].Fix(VELOCITY_X); -NODES[678].Fix(VELOCITY_Y); -NODES[678].Fix(VELOCITY_Z); -NODES[679].Fix(VELOCITY_X); -NODES[679].Fix(VELOCITY_Y); -NODES[679].Fix(VELOCITY_Z); -NODES[680].Fix(VELOCITY_X); -NODES[680].Fix(VELOCITY_Y); -NODES[680].Fix(VELOCITY_Z); -NODES[681].Fix(VELOCITY_X); -NODES[681].Fix(VELOCITY_Y); -NODES[681].Fix(VELOCITY_Z); -NODES[682].Fix(VELOCITY_X); -NODES[682].Fix(VELOCITY_Y); -NODES[682].Fix(VELOCITY_Z); -NODES[683].Fix(VELOCITY_X); -NODES[683].Fix(VELOCITY_Y); -NODES[683].Fix(VELOCITY_Z); -NODES[684].Fix(VELOCITY_X); -NODES[684].Fix(VELOCITY_Y); -NODES[684].Fix(VELOCITY_Z); -NODES[685].Fix(VELOCITY_X); -NODES[685].Fix(VELOCITY_Y); -NODES[685].Fix(VELOCITY_Z); -NODES[686].Fix(VELOCITY_X); -NODES[686].Fix(VELOCITY_Y); -NODES[686].Fix(VELOCITY_Z); -NODES[687].Fix(VELOCITY_X); -NODES[687].Fix(VELOCITY_Y); -NODES[687].Fix(VELOCITY_Z); -NODES[688].Fix(VELOCITY_X); -NODES[688].Fix(VELOCITY_Y); -NODES[688].Fix(VELOCITY_Z); -NODES[689].Fix(VELOCITY_X); -NODES[689].Fix(VELOCITY_Y); -NODES[689].Fix(VELOCITY_Z); -NODES[690].Fix(VELOCITY_X); -NODES[690].Fix(VELOCITY_Y); -NODES[690].Fix(VELOCITY_Z); -NODES[691].Fix(VELOCITY_X); -NODES[691].Fix(VELOCITY_Y); -NODES[691].Fix(VELOCITY_Z); -NODES[692].Fix(VELOCITY_X); -NODES[692].Fix(VELOCITY_Y); -NODES[692].Fix(VELOCITY_Z); -NODES[693].Fix(VELOCITY_X); -NODES[693].Fix(VELOCITY_Y); -NODES[693].Fix(VELOCITY_Z); -NODES[694].Fix(VELOCITY_X); -NODES[694].Fix(VELOCITY_Y); -NODES[694].Fix(VELOCITY_Z); -NODES[695].Fix(VELOCITY_X); -NODES[695].Fix(VELOCITY_Y); -NODES[695].Fix(VELOCITY_Z); -NODES[696].Fix(VELOCITY_X); -NODES[696].Fix(VELOCITY_Y); -NODES[696].Fix(VELOCITY_Z); -NODES[697].Fix(VELOCITY_X); -NODES[697].Fix(VELOCITY_Y); -NODES[697].Fix(VELOCITY_Z); -NODES[698].Fix(VELOCITY_X); -NODES[698].Fix(VELOCITY_Y); -NODES[698].Fix(VELOCITY_Z); -NODES[699].Fix(VELOCITY_X); -NODES[699].Fix(VELOCITY_Y); -NODES[699].Fix(VELOCITY_Z); -NODES[700].Fix(VELOCITY_X); -NODES[700].Fix(VELOCITY_Y); -NODES[700].Fix(VELOCITY_Z); -NODES[701].Fix(VELOCITY_X); -NODES[701].Fix(VELOCITY_Y); -NODES[701].Fix(VELOCITY_Z); -NODES[702].Fix(VELOCITY_X); -NODES[702].Fix(VELOCITY_Y); -NODES[702].Fix(VELOCITY_Z); -NODES[703].Fix(VELOCITY_X); -NODES[703].Fix(VELOCITY_Y); -NODES[703].Fix(VELOCITY_Z); -NODES[704].Fix(VELOCITY_X); -NODES[704].Fix(VELOCITY_Y); -NODES[704].Fix(VELOCITY_Z); -NODES[705].Fix(VELOCITY_X); -NODES[705].Fix(VELOCITY_Y); -NODES[705].Fix(VELOCITY_Z); -NODES[706].Fix(VELOCITY_X); -NODES[706].Fix(VELOCITY_Y); -NODES[706].Fix(VELOCITY_Z); -NODES[707].Fix(VELOCITY_X); -NODES[707].Fix(VELOCITY_Y); -NODES[707].Fix(VELOCITY_Z); -NODES[708].Fix(VELOCITY_X); -NODES[708].Fix(VELOCITY_Y); -NODES[708].Fix(VELOCITY_Z); -NODES[709].Fix(VELOCITY_X); -NODES[709].Fix(VELOCITY_Y); -NODES[709].Fix(VELOCITY_Z); -NODES[710].Fix(VELOCITY_X); -NODES[710].Fix(VELOCITY_Y); -NODES[710].Fix(VELOCITY_Z); -NODES[711].Fix(VELOCITY_X); -NODES[711].Fix(VELOCITY_Y); -NODES[711].Fix(VELOCITY_Z); -NODES[712].Fix(VELOCITY_X); -NODES[712].Fix(VELOCITY_Y); -NODES[712].Fix(VELOCITY_Z); -NODES[713].Fix(VELOCITY_X); -NODES[713].Fix(VELOCITY_Y); -NODES[713].Fix(VELOCITY_Z); -NODES[714].Fix(VELOCITY_X); -NODES[714].Fix(VELOCITY_Y); -NODES[714].Fix(VELOCITY_Z); -NODES[715].Fix(VELOCITY_X); -NODES[715].Fix(VELOCITY_Y); -NODES[715].Fix(VELOCITY_Z); -NODES[716].Fix(VELOCITY_X); -NODES[716].Fix(VELOCITY_Y); -NODES[716].Fix(VELOCITY_Z); -NODES[717].Fix(VELOCITY_X); -NODES[717].Fix(VELOCITY_Y); -NODES[717].Fix(VELOCITY_Z); -NODES[718].Fix(VELOCITY_X); -NODES[718].Fix(VELOCITY_Y); -NODES[718].Fix(VELOCITY_Z); -NODES[719].Fix(VELOCITY_X); -NODES[719].Fix(VELOCITY_Y); -NODES[719].Fix(VELOCITY_Z); -NODES[720].Fix(VELOCITY_X); -NODES[720].Fix(VELOCITY_Y); -NODES[720].Fix(VELOCITY_Z); -NODES[721].Fix(VELOCITY_X); -NODES[721].Fix(VELOCITY_Y); -NODES[721].Fix(VELOCITY_Z); -NODES[722].Fix(VELOCITY_X); -NODES[722].Fix(VELOCITY_Y); -NODES[722].Fix(VELOCITY_Z); -NODES[723].Fix(VELOCITY_X); -NODES[723].Fix(VELOCITY_Y); -NODES[723].Fix(VELOCITY_Z); -NODES[724].Fix(VELOCITY_X); -NODES[724].Fix(VELOCITY_Y); -NODES[724].Fix(VELOCITY_Z); -NODES[725].Fix(VELOCITY_X); -NODES[725].Fix(VELOCITY_Y); -NODES[725].Fix(VELOCITY_Z); -NODES[726].Fix(VELOCITY_X); -NODES[726].Fix(VELOCITY_Y); -NODES[726].Fix(VELOCITY_Z); -NODES[727].Fix(VELOCITY_X); -NODES[727].Fix(VELOCITY_Y); -NODES[727].Fix(VELOCITY_Z); -NODES[728].Fix(VELOCITY_X); -NODES[728].Fix(VELOCITY_Y); -NODES[728].Fix(VELOCITY_Z); -NODES[729].Fix(VELOCITY_X); -NODES[729].Fix(VELOCITY_Y); -NODES[729].Fix(VELOCITY_Z); -NODES[730].Fix(VELOCITY_X); -NODES[730].Fix(VELOCITY_Y); -NODES[730].Fix(VELOCITY_Z); -NODES[731].Fix(VELOCITY_X); -NODES[731].Fix(VELOCITY_Y); -NODES[731].Fix(VELOCITY_Z); -NODES[732].Fix(VELOCITY_X); -NODES[732].Fix(VELOCITY_Y); -NODES[732].Fix(VELOCITY_Z); -NODES[733].Fix(VELOCITY_X); -NODES[733].Fix(VELOCITY_Y); -NODES[733].Fix(VELOCITY_Z); -NODES[734].Fix(VELOCITY_X); -NODES[734].Fix(VELOCITY_Y); -NODES[734].Fix(VELOCITY_Z); -NODES[735].Fix(VELOCITY_X); -NODES[735].Fix(VELOCITY_Y); -NODES[735].Fix(VELOCITY_Z); -NODES[736].Fix(VELOCITY_X); -NODES[736].Fix(VELOCITY_Y); -NODES[736].Fix(VELOCITY_Z); -NODES[737].Fix(VELOCITY_X); -NODES[737].Fix(VELOCITY_Y); -NODES[737].Fix(VELOCITY_Z); -NODES[738].Fix(VELOCITY_X); -NODES[738].Fix(VELOCITY_Y); -NODES[738].Fix(VELOCITY_Z); -NODES[739].Fix(VELOCITY_X); -NODES[739].Fix(VELOCITY_Y); -NODES[739].Fix(VELOCITY_Z); -NODES[740].Fix(VELOCITY_X); -NODES[740].Fix(VELOCITY_Y); -NODES[740].Fix(VELOCITY_Z); -NODES[741].Fix(VELOCITY_X); -NODES[741].Fix(VELOCITY_Y); -NODES[741].Fix(VELOCITY_Z); -NODES[742].Fix(VELOCITY_X); -NODES[742].Fix(VELOCITY_Y); -NODES[742].Fix(VELOCITY_Z); -NODES[743].Fix(VELOCITY_X); -NODES[743].Fix(VELOCITY_Y); -NODES[743].Fix(VELOCITY_Z); -NODES[744].Fix(VELOCITY_X); -NODES[744].Fix(VELOCITY_Y); -NODES[744].Fix(VELOCITY_Z); -NODES[745].Fix(VELOCITY_X); -NODES[745].Fix(VELOCITY_Y); -NODES[745].Fix(VELOCITY_Z); -NODES[746].Fix(VELOCITY_X); -NODES[746].Fix(VELOCITY_Y); -NODES[746].Fix(VELOCITY_Z); -NODES[747].Fix(VELOCITY_X); -NODES[747].Fix(VELOCITY_Y); -NODES[747].Fix(VELOCITY_Z); -NODES[748].Fix(VELOCITY_X); -NODES[748].Fix(VELOCITY_Y); -NODES[748].Fix(VELOCITY_Z); -NODES[749].Fix(VELOCITY_X); -NODES[749].Fix(VELOCITY_Y); -NODES[749].Fix(VELOCITY_Z); -NODES[750].Fix(VELOCITY_X); -NODES[750].Fix(VELOCITY_Y); -NODES[750].Fix(VELOCITY_Z); -NODES[751].Fix(VELOCITY_X); -NODES[751].Fix(VELOCITY_Y); -NODES[751].Fix(VELOCITY_Z); -NODES[752].Fix(VELOCITY_X); -NODES[752].Fix(VELOCITY_Y); -NODES[752].Fix(VELOCITY_Z); -NODES[753].Fix(VELOCITY_X); -NODES[753].Fix(VELOCITY_Y); -NODES[753].Fix(VELOCITY_Z); -NODES[754].Fix(VELOCITY_X); -NODES[754].Fix(VELOCITY_Y); -NODES[754].Fix(VELOCITY_Z); -NODES[755].Fix(VELOCITY_X); -NODES[755].Fix(VELOCITY_Y); -NODES[755].Fix(VELOCITY_Z); -NODES[756].Fix(VELOCITY_X); -NODES[756].Fix(VELOCITY_Y); -NODES[756].Fix(VELOCITY_Z); -NODES[757].Fix(VELOCITY_X); -NODES[757].Fix(VELOCITY_Y); -NODES[757].Fix(VELOCITY_Z); -NODES[758].Fix(VELOCITY_X); -NODES[758].Fix(VELOCITY_Y); -NODES[758].Fix(VELOCITY_Z); -NODES[759].Fix(VELOCITY_X); -NODES[759].Fix(VELOCITY_Y); -NODES[759].Fix(VELOCITY_Z); -NODES[760].Fix(VELOCITY_X); -NODES[760].Fix(VELOCITY_Y); -NODES[760].Fix(VELOCITY_Z); -NODES[761].Fix(VELOCITY_X); -NODES[761].Fix(VELOCITY_Y); -NODES[761].Fix(VELOCITY_Z); -NODES[762].Fix(VELOCITY_X); -NODES[762].Fix(VELOCITY_Y); -NODES[762].Fix(VELOCITY_Z); -NODES[763].Fix(VELOCITY_X); -NODES[763].Fix(VELOCITY_Y); -NODES[763].Fix(VELOCITY_Z); -NODES[764].Fix(VELOCITY_X); -NODES[764].Fix(VELOCITY_Y); -NODES[764].Fix(VELOCITY_Z); -NODES[765].Fix(VELOCITY_X); -NODES[765].Fix(VELOCITY_Y); -NODES[765].Fix(VELOCITY_Z); -NODES[766].Fix(VELOCITY_X); -NODES[766].Fix(VELOCITY_Y); -NODES[766].Fix(VELOCITY_Z); -NODES[767].Fix(VELOCITY_X); -NODES[767].Fix(VELOCITY_Y); -NODES[767].Fix(VELOCITY_Z); -NODES[768].Fix(VELOCITY_X); -NODES[768].Fix(VELOCITY_Y); -NODES[768].Fix(VELOCITY_Z); -NODES[769].Fix(VELOCITY_X); -NODES[769].Fix(VELOCITY_Y); -NODES[769].Fix(VELOCITY_Z); -NODES[770].Fix(VELOCITY_X); -NODES[770].Fix(VELOCITY_Y); -NODES[770].Fix(VELOCITY_Z); -NODES[771].Fix(VELOCITY_X); -NODES[771].Fix(VELOCITY_Y); -NODES[771].Fix(VELOCITY_Z); -NODES[772].Fix(VELOCITY_X); -NODES[772].Fix(VELOCITY_Y); -NODES[772].Fix(VELOCITY_Z); -NODES[773].Fix(VELOCITY_X); -NODES[773].Fix(VELOCITY_Y); -NODES[773].Fix(VELOCITY_Z); -NODES[774].Fix(VELOCITY_X); -NODES[774].Fix(VELOCITY_Y); -NODES[774].Fix(VELOCITY_Z); -NODES[775].Fix(VELOCITY_X); -NODES[775].Fix(VELOCITY_Y); -NODES[775].Fix(VELOCITY_Z); -NODES[776].Fix(VELOCITY_X); -NODES[776].Fix(VELOCITY_Y); -NODES[776].Fix(VELOCITY_Z); -NODES[777].Fix(VELOCITY_X); -NODES[777].Fix(VELOCITY_Y); -NODES[777].Fix(VELOCITY_Z); -NODES[778].Fix(VELOCITY_X); -NODES[778].Fix(VELOCITY_Y); -NODES[778].Fix(VELOCITY_Z); -NODES[779].Fix(VELOCITY_X); -NODES[779].Fix(VELOCITY_Y); -NODES[779].Fix(VELOCITY_Z); -NODES[780].Fix(VELOCITY_X); -NODES[780].Fix(VELOCITY_Y); -NODES[780].Fix(VELOCITY_Z); -NODES[781].Fix(VELOCITY_X); -NODES[781].Fix(VELOCITY_Y); -NODES[781].Fix(VELOCITY_Z); -NODES[782].Fix(VELOCITY_X); -NODES[782].Fix(VELOCITY_Y); -NODES[782].Fix(VELOCITY_Z); -NODES[783].Fix(VELOCITY_X); -NODES[783].Fix(VELOCITY_Y); -NODES[783].Fix(VELOCITY_Z); -NODES[784].Fix(VELOCITY_X); -NODES[784].Fix(VELOCITY_Y); -NODES[784].Fix(VELOCITY_Z); -NODES[785].Fix(VELOCITY_X); -NODES[785].Fix(VELOCITY_Y); -NODES[785].Fix(VELOCITY_Z); -NODES[786].Fix(VELOCITY_X); -NODES[786].Fix(VELOCITY_Y); -NODES[786].Fix(VELOCITY_Z); -NODES[787].Fix(VELOCITY_X); -NODES[787].Fix(VELOCITY_Y); -NODES[787].Fix(VELOCITY_Z); -NODES[788].Fix(VELOCITY_X); -NODES[788].Fix(VELOCITY_Y); -NODES[788].Fix(VELOCITY_Z); -NODES[789].Fix(VELOCITY_X); -NODES[789].Fix(VELOCITY_Y); -NODES[789].Fix(VELOCITY_Z); -NODES[790].Fix(VELOCITY_X); -NODES[790].Fix(VELOCITY_Y); -NODES[790].Fix(VELOCITY_Z); -NODES[791].Fix(VELOCITY_X); -NODES[791].Fix(VELOCITY_Y); -NODES[791].Fix(VELOCITY_Z); -NODES[792].Fix(VELOCITY_X); -NODES[792].Fix(VELOCITY_Y); -NODES[792].Fix(VELOCITY_Z); -NODES[793].Fix(VELOCITY_X); -NODES[793].Fix(VELOCITY_Y); -NODES[793].Fix(VELOCITY_Z); -NODES[794].Fix(VELOCITY_X); -NODES[794].Fix(VELOCITY_Y); -NODES[794].Fix(VELOCITY_Z); -NODES[795].Fix(VELOCITY_X); -NODES[795].Fix(VELOCITY_Y); -NODES[795].Fix(VELOCITY_Z); -NODES[796].Fix(VELOCITY_X); -NODES[796].Fix(VELOCITY_Y); -NODES[796].Fix(VELOCITY_Z); -NODES[797].Fix(VELOCITY_X); -NODES[797].Fix(VELOCITY_Y); -NODES[797].Fix(VELOCITY_Z); -NODES[798].Fix(VELOCITY_X); -NODES[798].Fix(VELOCITY_Y); -NODES[798].Fix(VELOCITY_Z); -NODES[799].Fix(VELOCITY_X); -NODES[799].Fix(VELOCITY_Y); -NODES[799].Fix(VELOCITY_Z); -NODES[800].Fix(VELOCITY_X); -NODES[800].Fix(VELOCITY_Y); -NODES[800].Fix(VELOCITY_Z); -NODES[801].Fix(VELOCITY_X); -NODES[801].Fix(VELOCITY_Y); -NODES[801].Fix(VELOCITY_Z); -NODES[802].Fix(VELOCITY_X); -NODES[802].Fix(VELOCITY_Y); -NODES[802].Fix(VELOCITY_Z); -NODES[803].Fix(VELOCITY_X); -NODES[803].Fix(VELOCITY_Y); -NODES[803].Fix(VELOCITY_Z); -NODES[804].Fix(VELOCITY_X); -NODES[804].Fix(VELOCITY_Y); -NODES[804].Fix(VELOCITY_Z); -NODES[805].Fix(VELOCITY_X); -NODES[805].Fix(VELOCITY_Y); -NODES[805].Fix(VELOCITY_Z); -NODES[806].Fix(VELOCITY_X); -NODES[806].Fix(VELOCITY_Y); -NODES[806].Fix(VELOCITY_Z); -NODES[807].Fix(VELOCITY_X); -NODES[807].Fix(VELOCITY_Y); -NODES[807].Fix(VELOCITY_Z); -NODES[808].Fix(VELOCITY_X); -NODES[808].Fix(VELOCITY_Y); -NODES[808].Fix(VELOCITY_Z); -NODES[809].Fix(VELOCITY_X); -NODES[809].Fix(VELOCITY_Y); -NODES[809].Fix(VELOCITY_Z); -NODES[810].Fix(VELOCITY_X); -NODES[810].Fix(VELOCITY_Y); -NODES[810].Fix(VELOCITY_Z); -NODES[811].Fix(VELOCITY_X); -NODES[811].Fix(VELOCITY_Y); -NODES[811].Fix(VELOCITY_Z); -NODES[812].Fix(VELOCITY_X); -NODES[812].Fix(VELOCITY_Y); -NODES[812].Fix(VELOCITY_Z); -NODES[813].Fix(VELOCITY_X); -NODES[813].Fix(VELOCITY_Y); -NODES[813].Fix(VELOCITY_Z); -NODES[814].Fix(VELOCITY_X); -NODES[814].Fix(VELOCITY_Y); -NODES[814].Fix(VELOCITY_Z); -NODES[815].Fix(VELOCITY_X); -NODES[815].Fix(VELOCITY_Y); -NODES[815].Fix(VELOCITY_Z); -NODES[816].Fix(VELOCITY_X); -NODES[816].Fix(VELOCITY_Y); -NODES[816].Fix(VELOCITY_Z); -NODES[817].Fix(VELOCITY_X); -NODES[817].Fix(VELOCITY_Y); -NODES[817].Fix(VELOCITY_Z); -NODES[818].Fix(VELOCITY_X); -NODES[818].Fix(VELOCITY_Y); -NODES[818].Fix(VELOCITY_Z); -NODES[819].Fix(VELOCITY_X); -NODES[819].Fix(VELOCITY_Y); -NODES[819].Fix(VELOCITY_Z); -NODES[820].Fix(VELOCITY_X); -NODES[820].Fix(VELOCITY_Y); -NODES[820].Fix(VELOCITY_Z); -NODES[821].Fix(VELOCITY_X); -NODES[821].Fix(VELOCITY_Y); -NODES[821].Fix(VELOCITY_Z); -NODES[822].Fix(VELOCITY_X); -NODES[822].Fix(VELOCITY_Y); -NODES[822].Fix(VELOCITY_Z); -NODES[823].Fix(VELOCITY_X); -NODES[823].Fix(VELOCITY_Y); -NODES[823].Fix(VELOCITY_Z); -NODES[824].Fix(VELOCITY_X); -NODES[824].Fix(VELOCITY_Y); -NODES[824].Fix(VELOCITY_Z); -NODES[825].Fix(VELOCITY_X); -NODES[825].Fix(VELOCITY_Y); -NODES[825].Fix(VELOCITY_Z); -NODES[826].Fix(VELOCITY_X); -NODES[826].Fix(VELOCITY_Y); -NODES[826].Fix(VELOCITY_Z); -NODES[827].Fix(VELOCITY_X); -NODES[827].Fix(VELOCITY_Y); -NODES[827].Fix(VELOCITY_Z); -NODES[828].Fix(VELOCITY_X); -NODES[828].Fix(VELOCITY_Y); -NODES[828].Fix(VELOCITY_Z); -NODES[829].Fix(VELOCITY_X); -NODES[829].Fix(VELOCITY_Y); -NODES[829].Fix(VELOCITY_Z); -NODES[830].Fix(VELOCITY_X); -NODES[830].Fix(VELOCITY_Y); -NODES[830].Fix(VELOCITY_Z); -NODES[831].Fix(VELOCITY_X); -NODES[831].Fix(VELOCITY_Y); -NODES[831].Fix(VELOCITY_Z); -NODES[832].Fix(VELOCITY_X); -NODES[832].Fix(VELOCITY_Y); -NODES[832].Fix(VELOCITY_Z); -NODES[833].Fix(VELOCITY_X); -NODES[833].Fix(VELOCITY_Y); -NODES[833].Fix(VELOCITY_Z); -NODES[834].Fix(VELOCITY_X); -NODES[834].Fix(VELOCITY_Y); -NODES[834].Fix(VELOCITY_Z); -NODES[835].Fix(VELOCITY_X); -NODES[835].Fix(VELOCITY_Y); -NODES[835].Fix(VELOCITY_Z); -NODES[836].Fix(VELOCITY_X); -NODES[836].Fix(VELOCITY_Y); -NODES[836].Fix(VELOCITY_Z); -NODES[837].Fix(VELOCITY_X); -NODES[837].Fix(VELOCITY_Y); -NODES[837].Fix(VELOCITY_Z); -NODES[838].Fix(VELOCITY_X); -NODES[838].Fix(VELOCITY_Y); -NODES[838].Fix(VELOCITY_Z); -NODES[839].Fix(VELOCITY_X); -NODES[839].Fix(VELOCITY_Y); -NODES[839].Fix(VELOCITY_Z); -NODES[840].Fix(VELOCITY_X); -NODES[840].Fix(VELOCITY_Y); -NODES[840].Fix(VELOCITY_Z); -NODES[841].Fix(VELOCITY_X); -NODES[841].Fix(VELOCITY_Y); -NODES[841].Fix(VELOCITY_Z); -NODES[842].Fix(VELOCITY_X); -NODES[842].Fix(VELOCITY_Y); -NODES[842].Fix(VELOCITY_Z); -NODES[843].Fix(VELOCITY_X); -NODES[843].Fix(VELOCITY_Y); -NODES[843].Fix(VELOCITY_Z); -NODES[844].Fix(VELOCITY_X); -NODES[844].Fix(VELOCITY_Y); -NODES[844].Fix(VELOCITY_Z); -NODES[845].Fix(VELOCITY_X); -NODES[845].Fix(VELOCITY_Y); -NODES[845].Fix(VELOCITY_Z); -NODES[846].Fix(VELOCITY_X); -NODES[846].Fix(VELOCITY_Y); -NODES[846].Fix(VELOCITY_Z); -NODES[847].Fix(VELOCITY_X); -NODES[847].Fix(VELOCITY_Y); -NODES[847].Fix(VELOCITY_Z); -NODES[848].Fix(VELOCITY_X); -NODES[848].Fix(VELOCITY_Y); -NODES[848].Fix(VELOCITY_Z); -NODES[849].Fix(VELOCITY_X); -NODES[849].Fix(VELOCITY_Y); -NODES[849].Fix(VELOCITY_Z); -NODES[850].Fix(VELOCITY_X); -NODES[850].Fix(VELOCITY_Y); -NODES[850].Fix(VELOCITY_Z); -NODES[851].Fix(VELOCITY_X); -NODES[851].Fix(VELOCITY_Y); -NODES[851].Fix(VELOCITY_Z); -NODES[852].Fix(VELOCITY_X); -NODES[852].Fix(VELOCITY_Y); -NODES[852].Fix(VELOCITY_Z); -NODES[853].Fix(VELOCITY_X); -NODES[853].Fix(VELOCITY_Y); -NODES[853].Fix(VELOCITY_Z); -NODES[854].Fix(VELOCITY_X); -NODES[854].Fix(VELOCITY_Y); -NODES[854].Fix(VELOCITY_Z); -NODES[855].Fix(VELOCITY_X); -NODES[855].Fix(VELOCITY_Y); -NODES[855].Fix(VELOCITY_Z); -NODES[856].Fix(VELOCITY_X); -NODES[856].Fix(VELOCITY_Y); -NODES[856].Fix(VELOCITY_Z); -NODES[857].Fix(VELOCITY_X); -NODES[857].Fix(VELOCITY_Y); -NODES[857].Fix(VELOCITY_Z); -NODES[858].Fix(VELOCITY_X); -NODES[858].Fix(VELOCITY_Y); -NODES[858].Fix(VELOCITY_Z); -NODES[859].Fix(VELOCITY_X); -NODES[859].Fix(VELOCITY_Y); -NODES[859].Fix(VELOCITY_Z); -NODES[860].Fix(VELOCITY_X); -NODES[860].Fix(VELOCITY_Y); -NODES[860].Fix(VELOCITY_Z); -NODES[861].Fix(VELOCITY_X); -NODES[861].Fix(VELOCITY_Y); -NODES[861].Fix(VELOCITY_Z); -NODES[862].Fix(VELOCITY_X); -NODES[862].Fix(VELOCITY_Y); -NODES[862].Fix(VELOCITY_Z); -NODES[863].Fix(VELOCITY_X); -NODES[863].Fix(VELOCITY_Y); -NODES[863].Fix(VELOCITY_Z); -NODES[864].Fix(VELOCITY_X); -NODES[864].Fix(VELOCITY_Y); -NODES[864].Fix(VELOCITY_Z); -NODES[865].Fix(VELOCITY_X); -NODES[865].Fix(VELOCITY_Y); -NODES[865].Fix(VELOCITY_Z); -NODES[866].Fix(VELOCITY_X); -NODES[866].Fix(VELOCITY_Y); -NODES[866].Fix(VELOCITY_Z); -NODES[867].Fix(VELOCITY_X); -NODES[867].Fix(VELOCITY_Y); -NODES[867].Fix(VELOCITY_Z); -NODES[868].Fix(VELOCITY_X); -NODES[868].Fix(VELOCITY_Y); -NODES[868].Fix(VELOCITY_Z); -NODES[869].Fix(VELOCITY_X); -NODES[869].Fix(VELOCITY_Y); -NODES[869].Fix(VELOCITY_Z); -NODES[870].Fix(VELOCITY_X); -NODES[870].Fix(VELOCITY_Y); -NODES[870].Fix(VELOCITY_Z); -NODES[871].Fix(VELOCITY_X); -NODES[871].Fix(VELOCITY_Y); -NODES[871].Fix(VELOCITY_Z); -NODES[872].Fix(VELOCITY_X); -NODES[872].Fix(VELOCITY_Y); -NODES[872].Fix(VELOCITY_Z); -NODES[873].Fix(VELOCITY_X); -NODES[873].Fix(VELOCITY_Y); -NODES[873].Fix(VELOCITY_Z); -NODES[874].Fix(VELOCITY_X); -NODES[874].Fix(VELOCITY_Y); -NODES[874].Fix(VELOCITY_Z); -NODES[875].Fix(VELOCITY_X); -NODES[875].Fix(VELOCITY_Y); -NODES[875].Fix(VELOCITY_Z); -NODES[876].Fix(VELOCITY_X); -NODES[876].Fix(VELOCITY_Y); -NODES[876].Fix(VELOCITY_Z); -NODES[877].Fix(VELOCITY_X); -NODES[877].Fix(VELOCITY_Y); -NODES[877].Fix(VELOCITY_Z); -NODES[878].Fix(VELOCITY_X); -NODES[878].Fix(VELOCITY_Y); -NODES[878].Fix(VELOCITY_Z); -NODES[879].Fix(VELOCITY_X); -NODES[879].Fix(VELOCITY_Y); -NODES[879].Fix(VELOCITY_Z); -NODES[880].Fix(VELOCITY_X); -NODES[880].Fix(VELOCITY_Y); -NODES[880].Fix(VELOCITY_Z); -NODES[881].Fix(VELOCITY_X); -NODES[881].Fix(VELOCITY_Y); -NODES[881].Fix(VELOCITY_Z); -NODES[882].Fix(VELOCITY_X); -NODES[882].Fix(VELOCITY_Y); -NODES[882].Fix(VELOCITY_Z); -NODES[883].Fix(VELOCITY_X); -NODES[883].Fix(VELOCITY_Y); -NODES[883].Fix(VELOCITY_Z); -NODES[884].Fix(VELOCITY_X); -NODES[884].Fix(VELOCITY_Y); -NODES[884].Fix(VELOCITY_Z); -NODES[885].Fix(VELOCITY_X); -NODES[885].Fix(VELOCITY_Y); -NODES[885].Fix(VELOCITY_Z); -NODES[886].Fix(VELOCITY_X); -NODES[886].Fix(VELOCITY_Y); -NODES[886].Fix(VELOCITY_Z); -NODES[887].Fix(VELOCITY_X); -NODES[887].Fix(VELOCITY_Y); -NODES[887].Fix(VELOCITY_Z); -NODES[888].Fix(VELOCITY_X); -NODES[888].Fix(VELOCITY_Y); -NODES[888].Fix(VELOCITY_Z); -NODES[889].Fix(VELOCITY_X); -NODES[889].Fix(VELOCITY_Y); -NODES[889].Fix(VELOCITY_Z); -NODES[890].Fix(VELOCITY_X); -NODES[890].Fix(VELOCITY_Y); -NODES[890].Fix(VELOCITY_Z); -NODES[891].Fix(VELOCITY_X); -NODES[891].Fix(VELOCITY_Y); -NODES[891].Fix(VELOCITY_Z); -NODES[892].Fix(VELOCITY_X); -NODES[892].Fix(VELOCITY_Y); -NODES[892].Fix(VELOCITY_Z); -NODES[893].Fix(VELOCITY_X); -NODES[893].Fix(VELOCITY_Y); -NODES[893].Fix(VELOCITY_Z); -NODES[894].Fix(VELOCITY_X); -NODES[894].Fix(VELOCITY_Y); -NODES[894].Fix(VELOCITY_Z); -NODES[895].Fix(VELOCITY_X); -NODES[895].Fix(VELOCITY_Y); -NODES[895].Fix(VELOCITY_Z); -NODES[896].Fix(VELOCITY_X); -NODES[896].Fix(VELOCITY_Y); -NODES[896].Fix(VELOCITY_Z); -NODES[897].Fix(VELOCITY_X); -NODES[897].Fix(VELOCITY_Y); -NODES[897].Fix(VELOCITY_Z); -NODES[898].Fix(VELOCITY_X); -NODES[898].Fix(VELOCITY_Y); -NODES[898].Fix(VELOCITY_Z); -NODES[899].Fix(VELOCITY_X); -NODES[899].Fix(VELOCITY_Y); -NODES[899].Fix(VELOCITY_Z); -NODES[900].Fix(VELOCITY_X); -NODES[900].Fix(VELOCITY_Y); -NODES[900].Fix(VELOCITY_Z); -NODES[901].Fix(VELOCITY_X); -NODES[901].Fix(VELOCITY_Y); -NODES[901].Fix(VELOCITY_Z); -NODES[902].Fix(VELOCITY_X); -NODES[902].Fix(VELOCITY_Y); -NODES[902].Fix(VELOCITY_Z); -NODES[903].Fix(VELOCITY_X); -NODES[903].Fix(VELOCITY_Y); -NODES[903].Fix(VELOCITY_Z); -NODES[904].Fix(VELOCITY_X); -NODES[904].Fix(VELOCITY_Y); -NODES[904].Fix(VELOCITY_Z); -NODES[905].Fix(VELOCITY_X); -NODES[905].Fix(VELOCITY_Y); -NODES[905].Fix(VELOCITY_Z); -NODES[906].Fix(VELOCITY_X); -NODES[906].Fix(VELOCITY_Y); -NODES[906].Fix(VELOCITY_Z); -NODES[907].Fix(VELOCITY_X); -NODES[907].Fix(VELOCITY_Y); -NODES[907].Fix(VELOCITY_Z); -NODES[908].Fix(VELOCITY_X); -NODES[908].Fix(VELOCITY_Y); -NODES[908].Fix(VELOCITY_Z); -NODES[909].Fix(VELOCITY_X); -NODES[909].Fix(VELOCITY_Y); -NODES[909].Fix(VELOCITY_Z); -NODES[910].Fix(VELOCITY_X); -NODES[910].Fix(VELOCITY_Y); -NODES[910].Fix(VELOCITY_Z); -NODES[911].Fix(VELOCITY_X); -NODES[911].Fix(VELOCITY_Y); -NODES[911].Fix(VELOCITY_Z); -NODES[912].Fix(VELOCITY_X); -NODES[912].Fix(VELOCITY_Y); -NODES[912].Fix(VELOCITY_Z); -NODES[913].Fix(VELOCITY_X); -NODES[913].Fix(VELOCITY_Y); -NODES[913].Fix(VELOCITY_Z); -NODES[914].Fix(VELOCITY_X); -NODES[914].Fix(VELOCITY_Y); -NODES[914].Fix(VELOCITY_Z); -NODES[915].Fix(VELOCITY_X); -NODES[915].Fix(VELOCITY_Y); -NODES[915].Fix(VELOCITY_Z); -NODES[916].Fix(VELOCITY_X); -NODES[916].Fix(VELOCITY_Y); -NODES[916].Fix(VELOCITY_Z); -NODES[917].Fix(VELOCITY_X); -NODES[917].Fix(VELOCITY_Y); -NODES[917].Fix(VELOCITY_Z); -NODES[918].Fix(VELOCITY_X); -NODES[918].Fix(VELOCITY_Y); -NODES[918].Fix(VELOCITY_Z); -NODES[919].Fix(VELOCITY_X); -NODES[919].Fix(VELOCITY_Y); -NODES[919].Fix(VELOCITY_Z); -NODES[920].Fix(VELOCITY_X); -NODES[920].Fix(VELOCITY_Y); -NODES[920].Fix(VELOCITY_Z); -NODES[921].Fix(VELOCITY_X); -NODES[921].Fix(VELOCITY_Y); -NODES[921].Fix(VELOCITY_Z); -NODES[922].Fix(VELOCITY_X); -NODES[922].Fix(VELOCITY_Y); -NODES[922].Fix(VELOCITY_Z); -NODES[923].Fix(VELOCITY_X); -NODES[923].Fix(VELOCITY_Y); -NODES[923].Fix(VELOCITY_Z); -NODES[924].Fix(VELOCITY_X); -NODES[924].Fix(VELOCITY_Y); -NODES[924].Fix(VELOCITY_Z); -NODES[925].Fix(VELOCITY_X); -NODES[925].Fix(VELOCITY_Y); -NODES[925].Fix(VELOCITY_Z); -NODES[926].Fix(VELOCITY_X); -NODES[926].Fix(VELOCITY_Y); -NODES[926].Fix(VELOCITY_Z); -NODES[927].Fix(VELOCITY_X); -NODES[927].Fix(VELOCITY_Y); -NODES[927].Fix(VELOCITY_Z); -NODES[928].Fix(VELOCITY_X); -NODES[928].Fix(VELOCITY_Y); -NODES[928].Fix(VELOCITY_Z); -NODES[929].Fix(VELOCITY_X); -NODES[929].Fix(VELOCITY_Y); -NODES[929].Fix(VELOCITY_Z); -NODES[930].Fix(VELOCITY_X); -NODES[930].Fix(VELOCITY_Y); -NODES[930].Fix(VELOCITY_Z); -NODES[931].Fix(VELOCITY_X); -NODES[931].Fix(VELOCITY_Y); -NODES[931].Fix(VELOCITY_Z); -NODES[932].Fix(VELOCITY_X); -NODES[932].Fix(VELOCITY_Y); -NODES[932].Fix(VELOCITY_Z); -NODES[933].Fix(VELOCITY_X); -NODES[933].Fix(VELOCITY_Y); -NODES[933].Fix(VELOCITY_Z); -NODES[934].Fix(VELOCITY_X); -NODES[934].Fix(VELOCITY_Y); -NODES[934].Fix(VELOCITY_Z); -NODES[935].Fix(VELOCITY_X); -NODES[935].Fix(VELOCITY_Y); -NODES[935].Fix(VELOCITY_Z); -NODES[936].Fix(VELOCITY_X); -NODES[936].Fix(VELOCITY_Y); -NODES[936].Fix(VELOCITY_Z); -NODES[937].Fix(VELOCITY_X); -NODES[937].Fix(VELOCITY_Y); -NODES[937].Fix(VELOCITY_Z); -NODES[938].Fix(VELOCITY_X); -NODES[938].Fix(VELOCITY_Y); -NODES[938].Fix(VELOCITY_Z); -NODES[939].Fix(VELOCITY_X); -NODES[939].Fix(VELOCITY_Y); -NODES[939].Fix(VELOCITY_Z); -NODES[940].Fix(VELOCITY_X); -NODES[940].Fix(VELOCITY_Y); -NODES[940].Fix(VELOCITY_Z); -NODES[941].Fix(VELOCITY_X); -NODES[941].Fix(VELOCITY_Y); -NODES[941].Fix(VELOCITY_Z); -NODES[942].Fix(VELOCITY_X); -NODES[942].Fix(VELOCITY_Y); -NODES[942].Fix(VELOCITY_Z); -NODES[943].Fix(VELOCITY_X); -NODES[943].Fix(VELOCITY_Y); -NODES[943].Fix(VELOCITY_Z); -NODES[944].Fix(VELOCITY_X); -NODES[944].Fix(VELOCITY_Y); -NODES[944].Fix(VELOCITY_Z); -NODES[945].Fix(VELOCITY_X); -NODES[945].Fix(VELOCITY_Y); -NODES[945].Fix(VELOCITY_Z); -NODES[946].Fix(VELOCITY_X); -NODES[946].Fix(VELOCITY_Y); -NODES[946].Fix(VELOCITY_Z); -NODES[947].Fix(VELOCITY_X); -NODES[947].Fix(VELOCITY_Y); -NODES[947].Fix(VELOCITY_Z); -NODES[948].Fix(VELOCITY_X); -NODES[948].Fix(VELOCITY_Y); -NODES[948].Fix(VELOCITY_Z); -NODES[949].Fix(VELOCITY_X); -NODES[949].Fix(VELOCITY_Y); -NODES[949].Fix(VELOCITY_Z); -NODES[950].Fix(VELOCITY_X); -NODES[950].Fix(VELOCITY_Y); -NODES[950].Fix(VELOCITY_Z); -NODES[951].Fix(VELOCITY_X); -NODES[951].Fix(VELOCITY_Y); -NODES[951].Fix(VELOCITY_Z); -NODES[952].Fix(VELOCITY_X); -NODES[952].Fix(VELOCITY_Y); -NODES[952].Fix(VELOCITY_Z); -NODES[953].Fix(VELOCITY_X); -NODES[953].Fix(VELOCITY_Y); -NODES[953].Fix(VELOCITY_Z); -NODES[954].Fix(VELOCITY_X); -NODES[954].Fix(VELOCITY_Y); -NODES[954].Fix(VELOCITY_Z); -NODES[955].Fix(VELOCITY_X); -NODES[955].Fix(VELOCITY_Y); -NODES[955].Fix(VELOCITY_Z); -NODES[956].Fix(VELOCITY_X); -NODES[956].Fix(VELOCITY_Y); -NODES[956].Fix(VELOCITY_Z); -NODES[957].Fix(VELOCITY_X); -NODES[957].Fix(VELOCITY_Y); -NODES[957].Fix(VELOCITY_Z); -NODES[958].Fix(VELOCITY_X); -NODES[958].Fix(VELOCITY_Y); -NODES[958].Fix(VELOCITY_Z); -NODES[959].Fix(VELOCITY_X); -NODES[959].Fix(VELOCITY_Y); -NODES[959].Fix(VELOCITY_Z); -NODES[960].Fix(VELOCITY_X); -NODES[960].Fix(VELOCITY_Y); -NODES[960].Fix(VELOCITY_Z); -NODES[961].Fix(VELOCITY_X); -NODES[961].Fix(VELOCITY_Y); -NODES[961].Fix(VELOCITY_Z); -NODES[962].Fix(VELOCITY_X); -NODES[962].Fix(VELOCITY_Y); -NODES[962].Fix(VELOCITY_Z); -NODES[963].Fix(VELOCITY_X); -NODES[963].Fix(VELOCITY_Y); -NODES[963].Fix(VELOCITY_Z); -NODES[964].Fix(VELOCITY_X); -NODES[964].Fix(VELOCITY_Y); -NODES[964].Fix(VELOCITY_Z); -NODES[965].Fix(VELOCITY_X); -NODES[965].Fix(VELOCITY_Y); -NODES[965].Fix(VELOCITY_Z); -NODES[966].Fix(VELOCITY_X); -NODES[966].Fix(VELOCITY_Y); -NODES[966].Fix(VELOCITY_Z); -NODES[967].Fix(VELOCITY_X); -NODES[967].Fix(VELOCITY_Y); -NODES[967].Fix(VELOCITY_Z); -NODES[968].Fix(VELOCITY_X); -NODES[968].Fix(VELOCITY_Y); -NODES[968].Fix(VELOCITY_Z); -NODES[969].Fix(VELOCITY_X); -NODES[969].Fix(VELOCITY_Y); -NODES[969].Fix(VELOCITY_Z); -NODES[970].Fix(VELOCITY_X); -NODES[970].Fix(VELOCITY_Y); -NODES[970].Fix(VELOCITY_Z); -NODES[971].Fix(VELOCITY_X); -NODES[971].Fix(VELOCITY_Y); -NODES[971].Fix(VELOCITY_Z); -NODES[972].Fix(VELOCITY_X); -NODES[972].Fix(VELOCITY_Y); -NODES[972].Fix(VELOCITY_Z); -NODES[973].Fix(VELOCITY_X); -NODES[973].Fix(VELOCITY_Y); -NODES[973].Fix(VELOCITY_Z); -NODES[974].Fix(VELOCITY_X); -NODES[974].Fix(VELOCITY_Y); -NODES[974].Fix(VELOCITY_Z); -NODES[975].Fix(VELOCITY_X); -NODES[975].Fix(VELOCITY_Y); -NODES[975].Fix(VELOCITY_Z); -NODES[976].Fix(VELOCITY_X); -NODES[976].Fix(VELOCITY_Y); -NODES[976].Fix(VELOCITY_Z); -NODES[977].Fix(VELOCITY_X); -NODES[977].Fix(VELOCITY_Y); -NODES[977].Fix(VELOCITY_Z); -NODES[978].Fix(VELOCITY_X); -NODES[978].Fix(VELOCITY_Y); -NODES[978].Fix(VELOCITY_Z); -NODES[979].Fix(VELOCITY_X); -NODES[979].Fix(VELOCITY_Y); -NODES[979].Fix(VELOCITY_Z); -NODES[980].Fix(VELOCITY_X); -NODES[980].Fix(VELOCITY_Y); -NODES[980].Fix(VELOCITY_Z); -NODES[981].Fix(VELOCITY_X); -NODES[981].Fix(VELOCITY_Y); -NODES[981].Fix(VELOCITY_Z); -NODES[982].Fix(VELOCITY_X); -NODES[982].Fix(VELOCITY_Y); -NODES[982].Fix(VELOCITY_Z); -NODES[983].Fix(VELOCITY_X); -NODES[983].Fix(VELOCITY_Y); -NODES[983].Fix(VELOCITY_Z); -NODES[984].Fix(VELOCITY_X); -NODES[984].Fix(VELOCITY_Y); -NODES[984].Fix(VELOCITY_Z); -NODES[985].Fix(VELOCITY_X); -NODES[985].Fix(VELOCITY_Y); -NODES[985].Fix(VELOCITY_Z); -NODES[986].Fix(VELOCITY_X); -NODES[986].Fix(VELOCITY_Y); -NODES[986].Fix(VELOCITY_Z); -NODES[987].Fix(VELOCITY_X); -NODES[987].Fix(VELOCITY_Y); -NODES[987].Fix(VELOCITY_Z); -NODES[988].Fix(VELOCITY_X); -NODES[988].Fix(VELOCITY_Y); -NODES[988].Fix(VELOCITY_Z); -NODES[989].Fix(VELOCITY_X); -NODES[989].Fix(VELOCITY_Y); -NODES[989].Fix(VELOCITY_Z); -NODES[990].Fix(VELOCITY_X); -NODES[990].Fix(VELOCITY_Y); -NODES[990].Fix(VELOCITY_Z); -NODES[991].Fix(VELOCITY_X); -NODES[991].Fix(VELOCITY_Y); -NODES[991].Fix(VELOCITY_Z); -NODES[992].Fix(VELOCITY_X); -NODES[992].Fix(VELOCITY_Y); -NODES[992].Fix(VELOCITY_Z); -NODES[993].Fix(VELOCITY_X); -NODES[993].Fix(VELOCITY_Y); -NODES[993].Fix(VELOCITY_Z); -NODES[994].Fix(VELOCITY_X); -NODES[994].Fix(VELOCITY_Y); -NODES[994].Fix(VELOCITY_Z); -NODES[995].Fix(VELOCITY_X); -NODES[995].Fix(VELOCITY_Y); -NODES[995].Fix(VELOCITY_Z); -NODES[996].Fix(VELOCITY_X); -NODES[996].Fix(VELOCITY_Y); -NODES[996].Fix(VELOCITY_Z); -NODES[997].Fix(VELOCITY_X); -NODES[997].Fix(VELOCITY_Y); -NODES[997].Fix(VELOCITY_Z); -NODES[998].Fix(VELOCITY_X); -NODES[998].Fix(VELOCITY_Y); -NODES[998].Fix(VELOCITY_Z); -NODES[999].Fix(VELOCITY_X); -NODES[999].Fix(VELOCITY_Y); -NODES[999].Fix(VELOCITY_Z); -NODES[1000].Fix(VELOCITY_X); -NODES[1000].Fix(VELOCITY_Y); -NODES[1000].Fix(VELOCITY_Z); -NODES[1001].Fix(VELOCITY_X); -NODES[1001].Fix(VELOCITY_Y); -NODES[1001].Fix(VELOCITY_Z); -NODES[1002].Fix(VELOCITY_X); -NODES[1002].Fix(VELOCITY_Y); -NODES[1002].Fix(VELOCITY_Z); -NODES[1003].Fix(VELOCITY_X); -NODES[1003].Fix(VELOCITY_Y); -NODES[1003].Fix(VELOCITY_Z); -NODES[1004].Fix(VELOCITY_X); -NODES[1004].Fix(VELOCITY_Y); -NODES[1004].Fix(VELOCITY_Z); -NODES[1005].Fix(VELOCITY_X); -NODES[1005].Fix(VELOCITY_Y); -NODES[1005].Fix(VELOCITY_Z); -NODES[1006].Fix(VELOCITY_X); -NODES[1006].Fix(VELOCITY_Y); -NODES[1006].Fix(VELOCITY_Z); -NODES[1007].Fix(VELOCITY_X); -NODES[1007].Fix(VELOCITY_Y); -NODES[1007].Fix(VELOCITY_Z); -NODES[1008].Fix(VELOCITY_X); -NODES[1008].Fix(VELOCITY_Y); -NODES[1008].Fix(VELOCITY_Z); -NODES[1009].Fix(VELOCITY_X); -NODES[1009].Fix(VELOCITY_Y); -NODES[1009].Fix(VELOCITY_Z); -NODES[1010].Fix(VELOCITY_X); -NODES[1010].Fix(VELOCITY_Y); -NODES[1010].Fix(VELOCITY_Z); -NODES[1011].Fix(VELOCITY_X); -NODES[1011].Fix(VELOCITY_Y); -NODES[1011].Fix(VELOCITY_Z); -NODES[1012].Fix(VELOCITY_X); -NODES[1012].Fix(VELOCITY_Y); -NODES[1012].Fix(VELOCITY_Z); -NODES[1013].Fix(VELOCITY_X); -NODES[1013].Fix(VELOCITY_Y); -NODES[1013].Fix(VELOCITY_Z); -NODES[1014].Fix(VELOCITY_X); -NODES[1014].Fix(VELOCITY_Y); -NODES[1014].Fix(VELOCITY_Z); -NODES[1015].Fix(VELOCITY_X); -NODES[1015].Fix(VELOCITY_Y); -NODES[1015].Fix(VELOCITY_Z); -NODES[1016].Fix(VELOCITY_X); -NODES[1016].Fix(VELOCITY_Y); -NODES[1016].Fix(VELOCITY_Z); -NODES[1017].Fix(VELOCITY_X); -NODES[1017].Fix(VELOCITY_Y); -NODES[1017].Fix(VELOCITY_Z); -NODES[1018].Fix(VELOCITY_X); -NODES[1018].Fix(VELOCITY_Y); -NODES[1018].Fix(VELOCITY_Z); -NODES[1019].Fix(VELOCITY_X); -NODES[1019].Fix(VELOCITY_Y); -NODES[1019].Fix(VELOCITY_Z); -NODES[1020].Fix(VELOCITY_X); -NODES[1020].Fix(VELOCITY_Y); -NODES[1020].Fix(VELOCITY_Z); -NODES[1021].Fix(VELOCITY_X); -NODES[1021].Fix(VELOCITY_Y); -NODES[1021].Fix(VELOCITY_Z); -NODES[1022].Fix(VELOCITY_X); -NODES[1022].Fix(VELOCITY_Y); -NODES[1022].Fix(VELOCITY_Z); -NODES[1023].Fix(VELOCITY_X); -NODES[1023].Fix(VELOCITY_Y); -NODES[1023].Fix(VELOCITY_Z); -NODES[1024].Fix(VELOCITY_X); -NODES[1024].Fix(VELOCITY_Y); -NODES[1024].Fix(VELOCITY_Z); -NODES[1025].Fix(VELOCITY_X); -NODES[1025].Fix(VELOCITY_Y); -NODES[1025].Fix(VELOCITY_Z); -NODES[1026].Fix(VELOCITY_X); -NODES[1026].Fix(VELOCITY_Y); -NODES[1026].Fix(VELOCITY_Z); -NODES[1027].Fix(VELOCITY_X); -NODES[1027].Fix(VELOCITY_Y); -NODES[1027].Fix(VELOCITY_Z); -NODES[1028].Fix(VELOCITY_X); -NODES[1028].Fix(VELOCITY_Y); -NODES[1028].Fix(VELOCITY_Z); -NODES[1029].Fix(VELOCITY_X); -NODES[1029].Fix(VELOCITY_Y); -NODES[1029].Fix(VELOCITY_Z); -NODES[1030].Fix(VELOCITY_X); -NODES[1030].Fix(VELOCITY_Y); -NODES[1030].Fix(VELOCITY_Z); -NODES[1031].Fix(VELOCITY_X); -NODES[1031].Fix(VELOCITY_Y); -NODES[1031].Fix(VELOCITY_Z); -NODES[1032].Fix(VELOCITY_X); -NODES[1032].Fix(VELOCITY_Y); -NODES[1032].Fix(VELOCITY_Z); -NODES[1033].Fix(VELOCITY_X); -NODES[1033].Fix(VELOCITY_Y); -NODES[1033].Fix(VELOCITY_Z); -NODES[1034].Fix(VELOCITY_X); -NODES[1034].Fix(VELOCITY_Y); -NODES[1034].Fix(VELOCITY_Z); -NODES[1035].Fix(VELOCITY_X); -NODES[1035].Fix(VELOCITY_Y); -NODES[1035].Fix(VELOCITY_Z); -NODES[1036].Fix(VELOCITY_X); -NODES[1036].Fix(VELOCITY_Y); -NODES[1036].Fix(VELOCITY_Z); -NODES[1037].Fix(VELOCITY_X); -NODES[1037].Fix(VELOCITY_Y); -NODES[1037].Fix(VELOCITY_Z); -NODES[1038].Fix(VELOCITY_X); -NODES[1038].Fix(VELOCITY_Y); -NODES[1038].Fix(VELOCITY_Z); -NODES[1039].Fix(VELOCITY_X); -NODES[1039].Fix(VELOCITY_Y); -NODES[1039].Fix(VELOCITY_Z); -NODES[1040].Fix(VELOCITY_X); -NODES[1040].Fix(VELOCITY_Y); -NODES[1040].Fix(VELOCITY_Z); -NODES[1041].Fix(VELOCITY_X); -NODES[1041].Fix(VELOCITY_Y); -NODES[1041].Fix(VELOCITY_Z); -NODES[1042].Fix(VELOCITY_X); -NODES[1042].Fix(VELOCITY_Y); -NODES[1042].Fix(VELOCITY_Z); -NODES[1043].Fix(VELOCITY_X); -NODES[1043].Fix(VELOCITY_Y); -NODES[1043].Fix(VELOCITY_Z); -NODES[1044].Fix(VELOCITY_X); -NODES[1044].Fix(VELOCITY_Y); -NODES[1044].Fix(VELOCITY_Z); -NODES[1045].Fix(VELOCITY_X); -NODES[1045].Fix(VELOCITY_Y); -NODES[1045].Fix(VELOCITY_Z); -NODES[1046].Fix(VELOCITY_X); -NODES[1046].Fix(VELOCITY_Y); -NODES[1046].Fix(VELOCITY_Z); -NODES[1047].Fix(VELOCITY_X); -NODES[1047].Fix(VELOCITY_Y); -NODES[1047].Fix(VELOCITY_Z); -NODES[1048].Fix(VELOCITY_X); -NODES[1048].Fix(VELOCITY_Y); -NODES[1048].Fix(VELOCITY_Z); -NODES[1049].Fix(VELOCITY_X); -NODES[1049].Fix(VELOCITY_Y); -NODES[1049].Fix(VELOCITY_Z); -NODES[1050].Fix(VELOCITY_X); -NODES[1050].Fix(VELOCITY_Y); -NODES[1050].Fix(VELOCITY_Z); -NODES[1051].Fix(VELOCITY_X); -NODES[1051].Fix(VELOCITY_Y); -NODES[1051].Fix(VELOCITY_Z); -NODES[1052].Fix(VELOCITY_X); -NODES[1052].Fix(VELOCITY_Y); -NODES[1052].Fix(VELOCITY_Z); -NODES[1053].Fix(VELOCITY_X); -NODES[1053].Fix(VELOCITY_Y); -NODES[1053].Fix(VELOCITY_Z); -NODES[1054].Fix(VELOCITY_X); -NODES[1054].Fix(VELOCITY_Y); -NODES[1054].Fix(VELOCITY_Z); -NODES[1055].Fix(VELOCITY_X); -NODES[1055].Fix(VELOCITY_Y); -NODES[1055].Fix(VELOCITY_Z); -NODES[1056].Fix(VELOCITY_X); -NODES[1056].Fix(VELOCITY_Y); -NODES[1056].Fix(VELOCITY_Z); -NODES[1057].Fix(VELOCITY_X); -NODES[1057].Fix(VELOCITY_Y); -NODES[1057].Fix(VELOCITY_Z); -NODES[1058].Fix(VELOCITY_X); -NODES[1058].Fix(VELOCITY_Y); -NODES[1058].Fix(VELOCITY_Z); -NODES[1059].Fix(VELOCITY_X); -NODES[1059].Fix(VELOCITY_Y); -NODES[1059].Fix(VELOCITY_Z); -NODES[1060].Fix(VELOCITY_X); -NODES[1060].Fix(VELOCITY_Y); -NODES[1060].Fix(VELOCITY_Z); -NODES[1061].Fix(VELOCITY_X); -NODES[1061].Fix(VELOCITY_Y); -NODES[1061].Fix(VELOCITY_Z); -NODES[1062].Fix(VELOCITY_X); -NODES[1062].Fix(VELOCITY_Y); -NODES[1062].Fix(VELOCITY_Z); -NODES[1063].Fix(VELOCITY_X); -NODES[1063].Fix(VELOCITY_Y); -NODES[1063].Fix(VELOCITY_Z); -NODES[1064].Fix(VELOCITY_X); -NODES[1064].Fix(VELOCITY_Y); -NODES[1064].Fix(VELOCITY_Z); -NODES[1065].Fix(VELOCITY_X); -NODES[1065].Fix(VELOCITY_Y); -NODES[1065].Fix(VELOCITY_Z); -NODES[1066].Fix(VELOCITY_X); -NODES[1066].Fix(VELOCITY_Y); -NODES[1066].Fix(VELOCITY_Z); -NODES[1067].Fix(VELOCITY_X); -NODES[1067].Fix(VELOCITY_Y); -NODES[1067].Fix(VELOCITY_Z); -NODES[1068].Fix(VELOCITY_X); -NODES[1068].Fix(VELOCITY_Y); -NODES[1068].Fix(VELOCITY_Z); -NODES[1069].Fix(VELOCITY_X); -NODES[1069].Fix(VELOCITY_Y); -NODES[1069].Fix(VELOCITY_Z); -NODES[1070].Fix(VELOCITY_X); -NODES[1070].Fix(VELOCITY_Y); -NODES[1070].Fix(VELOCITY_Z); -NODES[1071].Fix(VELOCITY_X); -NODES[1071].Fix(VELOCITY_Y); -NODES[1071].Fix(VELOCITY_Z); -NODES[1072].Fix(VELOCITY_X); -NODES[1072].Fix(VELOCITY_Y); -NODES[1072].Fix(VELOCITY_Z); -NODES[1073].Fix(VELOCITY_X); -NODES[1073].Fix(VELOCITY_Y); -NODES[1073].Fix(VELOCITY_Z); -NODES[1074].Fix(VELOCITY_X); -NODES[1074].Fix(VELOCITY_Y); -NODES[1074].Fix(VELOCITY_Z); -NODES[1075].Fix(VELOCITY_X); -NODES[1075].Fix(VELOCITY_Y); -NODES[1075].Fix(VELOCITY_Z); -NODES[1076].Fix(VELOCITY_X); -NODES[1076].Fix(VELOCITY_Y); -NODES[1076].Fix(VELOCITY_Z); -NODES[1077].Fix(VELOCITY_X); -NODES[1077].Fix(VELOCITY_Y); -NODES[1077].Fix(VELOCITY_Z); -NODES[1078].Fix(VELOCITY_X); -NODES[1078].Fix(VELOCITY_Y); -NODES[1078].Fix(VELOCITY_Z); -NODES[1079].Fix(VELOCITY_X); -NODES[1079].Fix(VELOCITY_Y); -NODES[1079].Fix(VELOCITY_Z); -NODES[1080].Fix(VELOCITY_X); -NODES[1080].Fix(VELOCITY_Y); -NODES[1080].Fix(VELOCITY_Z); -NODES[1081].Fix(VELOCITY_X); -NODES[1081].Fix(VELOCITY_Y); -NODES[1081].Fix(VELOCITY_Z); -NODES[1082].Fix(VELOCITY_X); -NODES[1082].Fix(VELOCITY_Y); -NODES[1082].Fix(VELOCITY_Z); -NODES[1083].Fix(VELOCITY_X); -NODES[1083].Fix(VELOCITY_Y); -NODES[1083].Fix(VELOCITY_Z); -NODES[1084].Fix(VELOCITY_X); -NODES[1084].Fix(VELOCITY_Y); -NODES[1084].Fix(VELOCITY_Z); -NODES[1085].Fix(VELOCITY_X); -NODES[1085].Fix(VELOCITY_Y); -NODES[1085].Fix(VELOCITY_Z); -NODES[1086].Fix(VELOCITY_X); -NODES[1086].Fix(VELOCITY_Y); -NODES[1086].Fix(VELOCITY_Z); -NODES[1087].Fix(VELOCITY_X); -NODES[1087].Fix(VELOCITY_Y); -NODES[1087].Fix(VELOCITY_Z); -NODES[1088].Fix(VELOCITY_X); -NODES[1088].Fix(VELOCITY_Y); -NODES[1088].Fix(VELOCITY_Z); -NODES[1089].Fix(VELOCITY_X); -NODES[1089].Fix(VELOCITY_Y); -NODES[1089].Fix(VELOCITY_Z); -NODES[1090].Fix(VELOCITY_X); -NODES[1090].Fix(VELOCITY_Y); -NODES[1090].Fix(VELOCITY_Z); -NODES[1091].Fix(VELOCITY_X); -NODES[1091].Fix(VELOCITY_Y); -NODES[1091].Fix(VELOCITY_Z); -NODES[1092].Fix(VELOCITY_X); -NODES[1092].Fix(VELOCITY_Y); -NODES[1092].Fix(VELOCITY_Z); -NODES[1093].Fix(VELOCITY_X); -NODES[1093].Fix(VELOCITY_Y); -NODES[1093].Fix(VELOCITY_Z); -NODES[1094].Fix(VELOCITY_X); -NODES[1094].Fix(VELOCITY_Y); -NODES[1094].Fix(VELOCITY_Z); -NODES[1095].Fix(VELOCITY_X); -NODES[1095].Fix(VELOCITY_Y); -NODES[1095].Fix(VELOCITY_Z); -NODES[1096].Fix(VELOCITY_X); -NODES[1096].Fix(VELOCITY_Y); -NODES[1096].Fix(VELOCITY_Z); -NODES[1097].Fix(VELOCITY_X); -NODES[1097].Fix(VELOCITY_Y); -NODES[1097].Fix(VELOCITY_Z); -NODES[1098].Fix(VELOCITY_X); -NODES[1098].Fix(VELOCITY_Y); -NODES[1098].Fix(VELOCITY_Z); -NODES[1099].Fix(VELOCITY_X); -NODES[1099].Fix(VELOCITY_Y); -NODES[1099].Fix(VELOCITY_Z); -NODES[1100].Fix(VELOCITY_X); -NODES[1100].Fix(VELOCITY_Y); -NODES[1100].Fix(VELOCITY_Z); -NODES[1101].Fix(VELOCITY_X); -NODES[1101].Fix(VELOCITY_Y); -NODES[1101].Fix(VELOCITY_Z); -NODES[1102].Fix(VELOCITY_X); -NODES[1102].Fix(VELOCITY_Y); -NODES[1102].Fix(VELOCITY_Z); -NODES[1103].Fix(VELOCITY_X); -NODES[1103].Fix(VELOCITY_Y); -NODES[1103].Fix(VELOCITY_Z); -NODES[1104].Fix(VELOCITY_X); -NODES[1104].Fix(VELOCITY_Y); -NODES[1104].Fix(VELOCITY_Z); -NODES[1105].Fix(VELOCITY_X); -NODES[1105].Fix(VELOCITY_Y); -NODES[1105].Fix(VELOCITY_Z); -NODES[1106].Fix(VELOCITY_X); -NODES[1106].Fix(VELOCITY_Y); -NODES[1106].Fix(VELOCITY_Z); -NODES[1107].Fix(VELOCITY_X); -NODES[1107].Fix(VELOCITY_Y); -NODES[1107].Fix(VELOCITY_Z); -NODES[1108].Fix(VELOCITY_X); -NODES[1108].Fix(VELOCITY_Y); -NODES[1108].Fix(VELOCITY_Z); -NODES[1109].Fix(VELOCITY_X); -NODES[1109].Fix(VELOCITY_Y); -NODES[1109].Fix(VELOCITY_Z); -NODES[1110].Fix(VELOCITY_X); -NODES[1110].Fix(VELOCITY_Y); -NODES[1110].Fix(VELOCITY_Z); -NODES[1111].Fix(VELOCITY_X); -NODES[1111].Fix(VELOCITY_Y); -NODES[1111].Fix(VELOCITY_Z); -NODES[1112].Fix(VELOCITY_X); -NODES[1112].Fix(VELOCITY_Y); -NODES[1112].Fix(VELOCITY_Z); -NODES[1113].Fix(VELOCITY_X); -NODES[1113].Fix(VELOCITY_Y); -NODES[1113].Fix(VELOCITY_Z); -NODES[1114].Fix(VELOCITY_X); -NODES[1114].Fix(VELOCITY_Y); -NODES[1114].Fix(VELOCITY_Z); -NODES[1115].Fix(VELOCITY_X); -NODES[1115].Fix(VELOCITY_Y); -NODES[1115].Fix(VELOCITY_Z); -NODES[1116].Fix(VELOCITY_X); -NODES[1116].Fix(VELOCITY_Y); -NODES[1116].Fix(VELOCITY_Z); -NODES[1117].Fix(VELOCITY_X); -NODES[1117].Fix(VELOCITY_Y); -NODES[1117].Fix(VELOCITY_Z); -NODES[1118].Fix(VELOCITY_X); -NODES[1118].Fix(VELOCITY_Y); -NODES[1118].Fix(VELOCITY_Z); -NODES[1119].Fix(VELOCITY_X); -NODES[1119].Fix(VELOCITY_Y); -NODES[1119].Fix(VELOCITY_Z); -NODES[1120].Fix(VELOCITY_X); -NODES[1120].Fix(VELOCITY_Y); -NODES[1120].Fix(VELOCITY_Z); -NODES[1121].Fix(VELOCITY_X); -NODES[1121].Fix(VELOCITY_Y); -NODES[1121].Fix(VELOCITY_Z); -NODES[1122].Fix(VELOCITY_X); -NODES[1122].Fix(VELOCITY_Y); -NODES[1122].Fix(VELOCITY_Z); -NODES[1123].Fix(VELOCITY_X); -NODES[1123].Fix(VELOCITY_Y); -NODES[1123].Fix(VELOCITY_Z); -NODES[1124].Fix(VELOCITY_X); -NODES[1124].Fix(VELOCITY_Y); -NODES[1124].Fix(VELOCITY_Z); -NODES[1125].Fix(VELOCITY_X); -NODES[1125].Fix(VELOCITY_Y); -NODES[1125].Fix(VELOCITY_Z); -NODES[1126].Fix(VELOCITY_X); -NODES[1126].Fix(VELOCITY_Y); -NODES[1126].Fix(VELOCITY_Z); -NODES[1127].Fix(VELOCITY_X); -NODES[1127].Fix(VELOCITY_Y); -NODES[1127].Fix(VELOCITY_Z); -NODES[1128].Fix(VELOCITY_X); -NODES[1128].Fix(VELOCITY_Y); -NODES[1128].Fix(VELOCITY_Z); -NODES[1129].Fix(VELOCITY_X); -NODES[1129].Fix(VELOCITY_Y); -NODES[1129].Fix(VELOCITY_Z); -NODES[1130].Fix(VELOCITY_X); -NODES[1130].Fix(VELOCITY_Y); -NODES[1130].Fix(VELOCITY_Z); -NODES[1131].Fix(VELOCITY_X); -NODES[1131].Fix(VELOCITY_Y); -NODES[1131].Fix(VELOCITY_Z); -NODES[1132].Fix(VELOCITY_X); -NODES[1132].Fix(VELOCITY_Y); -NODES[1132].Fix(VELOCITY_Z); -NODES[1133].Fix(VELOCITY_X); -NODES[1133].Fix(VELOCITY_Y); -NODES[1133].Fix(VELOCITY_Z); -NODES[1134].Fix(VELOCITY_X); -NODES[1134].Fix(VELOCITY_Y); -NODES[1134].Fix(VELOCITY_Z); -NODES[1135].Fix(VELOCITY_X); -NODES[1135].Fix(VELOCITY_Y); -NODES[1135].Fix(VELOCITY_Z); -NODES[1136].Fix(VELOCITY_X); -NODES[1136].Fix(VELOCITY_Y); -NODES[1136].Fix(VELOCITY_Z); -NODES[1137].Fix(VELOCITY_X); -NODES[1137].Fix(VELOCITY_Y); -NODES[1137].Fix(VELOCITY_Z); -NODES[1138].Fix(VELOCITY_X); -NODES[1138].Fix(VELOCITY_Y); -NODES[1138].Fix(VELOCITY_Z); -NODES[1139].Fix(VELOCITY_X); -NODES[1139].Fix(VELOCITY_Y); -NODES[1139].Fix(VELOCITY_Z); -NODES[1140].Fix(VELOCITY_X); -NODES[1140].Fix(VELOCITY_Y); -NODES[1140].Fix(VELOCITY_Z); -NODES[1141].Fix(VELOCITY_X); -NODES[1141].Fix(VELOCITY_Y); -NODES[1141].Fix(VELOCITY_Z); -NODES[1142].Fix(VELOCITY_X); -NODES[1142].Fix(VELOCITY_Y); -NODES[1142].Fix(VELOCITY_Z); -NODES[1143].Fix(VELOCITY_X); -NODES[1143].Fix(VELOCITY_Y); -NODES[1143].Fix(VELOCITY_Z); -NODES[1144].Fix(VELOCITY_X); -NODES[1144].Fix(VELOCITY_Y); -NODES[1144].Fix(VELOCITY_Z); -NODES[1145].Fix(VELOCITY_X); -NODES[1145].Fix(VELOCITY_Y); -NODES[1145].Fix(VELOCITY_Z); -NODES[1146].Fix(VELOCITY_X); -NODES[1146].Fix(VELOCITY_Y); -NODES[1146].Fix(VELOCITY_Z); -NODES[1147].Fix(VELOCITY_X); -NODES[1147].Fix(VELOCITY_Y); -NODES[1147].Fix(VELOCITY_Z); -NODES[1148].Fix(VELOCITY_X); -NODES[1148].Fix(VELOCITY_Y); -NODES[1148].Fix(VELOCITY_Z); -NODES[1149].Fix(VELOCITY_X); -NODES[1149].Fix(VELOCITY_Y); -NODES[1149].Fix(VELOCITY_Z); -NODES[1150].Fix(VELOCITY_X); -NODES[1150].Fix(VELOCITY_Y); -NODES[1150].Fix(VELOCITY_Z); -NODES[1151].Fix(VELOCITY_X); -NODES[1151].Fix(VELOCITY_Y); -NODES[1151].Fix(VELOCITY_Z); -NODES[1152].Fix(VELOCITY_X); -NODES[1152].Fix(VELOCITY_Y); -NODES[1152].Fix(VELOCITY_Z); -NODES[1153].Fix(VELOCITY_X); -NODES[1153].Fix(VELOCITY_Y); -NODES[1153].Fix(VELOCITY_Z); -NODES[1154].Fix(VELOCITY_X); -NODES[1154].Fix(VELOCITY_Y); -NODES[1154].Fix(VELOCITY_Z); -NODES[1155].Fix(VELOCITY_X); -NODES[1155].Fix(VELOCITY_Y); -NODES[1155].Fix(VELOCITY_Z); -NODES[1156].Fix(VELOCITY_X); -NODES[1156].Fix(VELOCITY_Y); -NODES[1156].Fix(VELOCITY_Z); -NODES[1157].Fix(VELOCITY_X); -NODES[1157].Fix(VELOCITY_Y); -NODES[1157].Fix(VELOCITY_Z); -NODES[1158].Fix(VELOCITY_X); -NODES[1158].Fix(VELOCITY_Y); -NODES[1158].Fix(VELOCITY_Z); -NODES[1159].Fix(VELOCITY_X); -NODES[1159].Fix(VELOCITY_Y); -NODES[1159].Fix(VELOCITY_Z); -NODES[1160].Fix(VELOCITY_X); -NODES[1160].Fix(VELOCITY_Y); -NODES[1160].Fix(VELOCITY_Z); -NODES[1161].Fix(VELOCITY_X); -NODES[1161].Fix(VELOCITY_Y); -NODES[1161].Fix(VELOCITY_Z); -NODES[1162].Fix(VELOCITY_X); -NODES[1162].Fix(VELOCITY_Y); -NODES[1162].Fix(VELOCITY_Z); -NODES[1163].Fix(VELOCITY_X); -NODES[1163].Fix(VELOCITY_Y); -NODES[1163].Fix(VELOCITY_Z); -NODES[1164].Fix(VELOCITY_X); -NODES[1164].Fix(VELOCITY_Y); -NODES[1164].Fix(VELOCITY_Z); -NODES[1165].Fix(VELOCITY_X); -NODES[1165].Fix(VELOCITY_Y); -NODES[1165].Fix(VELOCITY_Z); -NODES[1166].Fix(VELOCITY_X); -NODES[1166].Fix(VELOCITY_Y); -NODES[1166].Fix(VELOCITY_Z); -NODES[1167].Fix(VELOCITY_X); -NODES[1167].Fix(VELOCITY_Y); -NODES[1167].Fix(VELOCITY_Z); -NODES[1168].Fix(VELOCITY_X); -NODES[1168].Fix(VELOCITY_Y); -NODES[1168].Fix(VELOCITY_Z); -NODES[1169].Fix(VELOCITY_X); -NODES[1169].Fix(VELOCITY_Y); -NODES[1169].Fix(VELOCITY_Z); -NODES[1170].Fix(VELOCITY_X); -NODES[1170].Fix(VELOCITY_Y); -NODES[1170].Fix(VELOCITY_Z); -NODES[1171].Fix(VELOCITY_X); -NODES[1171].Fix(VELOCITY_Y); -NODES[1171].Fix(VELOCITY_Z); -NODES[1172].Fix(VELOCITY_X); -NODES[1172].Fix(VELOCITY_Y); -NODES[1172].Fix(VELOCITY_Z); -NODES[1173].Fix(VELOCITY_X); -NODES[1173].Fix(VELOCITY_Y); -NODES[1173].Fix(VELOCITY_Z); -NODES[1174].Fix(VELOCITY_X); -NODES[1174].Fix(VELOCITY_Y); -NODES[1174].Fix(VELOCITY_Z); -NODES[1175].Fix(VELOCITY_X); -NODES[1175].Fix(VELOCITY_Y); -NODES[1175].Fix(VELOCITY_Z); -NODES[1176].Fix(VELOCITY_X); -NODES[1176].Fix(VELOCITY_Y); -NODES[1176].Fix(VELOCITY_Z); -NODES[1177].Fix(VELOCITY_X); -NODES[1177].Fix(VELOCITY_Y); -NODES[1177].Fix(VELOCITY_Z); -NODES[1178].Fix(VELOCITY_X); -NODES[1178].Fix(VELOCITY_Y); -NODES[1178].Fix(VELOCITY_Z); -NODES[1179].Fix(VELOCITY_X); -NODES[1179].Fix(VELOCITY_Y); -NODES[1179].Fix(VELOCITY_Z); -NODES[1180].Fix(VELOCITY_X); -NODES[1180].Fix(VELOCITY_Y); -NODES[1180].Fix(VELOCITY_Z); -NODES[1181].Fix(VELOCITY_X); -NODES[1181].Fix(VELOCITY_Y); -NODES[1181].Fix(VELOCITY_Z); -NODES[1182].Fix(VELOCITY_X); -NODES[1182].Fix(VELOCITY_Y); -NODES[1182].Fix(VELOCITY_Z); -NODES[1183].Fix(VELOCITY_X); -NODES[1183].Fix(VELOCITY_Y); -NODES[1183].Fix(VELOCITY_Z); -NODES[1184].Fix(VELOCITY_X); -NODES[1184].Fix(VELOCITY_Y); -NODES[1184].Fix(VELOCITY_Z); -NODES[1185].Fix(VELOCITY_X); -NODES[1185].Fix(VELOCITY_Y); -NODES[1185].Fix(VELOCITY_Z); -NODES[1186].Fix(VELOCITY_X); -NODES[1186].Fix(VELOCITY_Y); -NODES[1186].Fix(VELOCITY_Z); -NODES[1187].Fix(VELOCITY_X); -NODES[1187].Fix(VELOCITY_Y); -NODES[1187].Fix(VELOCITY_Z); -NODES[1188].Fix(VELOCITY_X); -NODES[1188].Fix(VELOCITY_Y); -NODES[1188].Fix(VELOCITY_Z); -NODES[1189].Fix(VELOCITY_X); -NODES[1189].Fix(VELOCITY_Y); -NODES[1189].Fix(VELOCITY_Z); -NODES[1190].Fix(VELOCITY_X); -NODES[1190].Fix(VELOCITY_Y); -NODES[1190].Fix(VELOCITY_Z); -NODES[1191].Fix(VELOCITY_X); -NODES[1191].Fix(VELOCITY_Y); -NODES[1191].Fix(VELOCITY_Z); -NODES[1192].Fix(VELOCITY_X); -NODES[1192].Fix(VELOCITY_Y); -NODES[1192].Fix(VELOCITY_Z); -NODES[1193].Fix(VELOCITY_X); -NODES[1193].Fix(VELOCITY_Y); -NODES[1193].Fix(VELOCITY_Z); -NODES[1194].Fix(VELOCITY_X); -NODES[1194].Fix(VELOCITY_Y); -NODES[1194].Fix(VELOCITY_Z); -NODES[1195].Fix(VELOCITY_X); -NODES[1195].Fix(VELOCITY_Y); -NODES[1195].Fix(VELOCITY_Z); -NODES[1196].Fix(VELOCITY_X); -NODES[1196].Fix(VELOCITY_Y); -NODES[1196].Fix(VELOCITY_Z); -NODES[1197].Fix(VELOCITY_X); -NODES[1197].Fix(VELOCITY_Y); -NODES[1197].Fix(VELOCITY_Z); -NODES[1198].Fix(VELOCITY_X); -NODES[1198].Fix(VELOCITY_Y); -NODES[1198].Fix(VELOCITY_Z); -NODES[1199].Fix(VELOCITY_X); -NODES[1199].Fix(VELOCITY_Y); -NODES[1199].Fix(VELOCITY_Z); -NODES[1200].Fix(VELOCITY_X); -NODES[1200].Fix(VELOCITY_Y); -NODES[1200].Fix(VELOCITY_Z); -NODES[1201].Fix(VELOCITY_X); -NODES[1201].Fix(VELOCITY_Y); -NODES[1201].Fix(VELOCITY_Z); -NODES[1202].Fix(VELOCITY_X); -NODES[1202].Fix(VELOCITY_Y); -NODES[1202].Fix(VELOCITY_Z); -NODES[1203].Fix(VELOCITY_X); -NODES[1203].Fix(VELOCITY_Y); -NODES[1203].Fix(VELOCITY_Z); -NODES[1204].Fix(VELOCITY_X); -NODES[1204].Fix(VELOCITY_Y); -NODES[1204].Fix(VELOCITY_Z); -NODES[1205].Fix(VELOCITY_X); -NODES[1205].Fix(VELOCITY_Y); -NODES[1205].Fix(VELOCITY_Z); -NODES[1206].Fix(VELOCITY_X); -NODES[1206].Fix(VELOCITY_Y); -NODES[1206].Fix(VELOCITY_Z); -NODES[1207].Fix(VELOCITY_X); -NODES[1207].Fix(VELOCITY_Y); -NODES[1207].Fix(VELOCITY_Z); -NODES[1208].Fix(VELOCITY_X); -NODES[1208].Fix(VELOCITY_Y); -NODES[1208].Fix(VELOCITY_Z); -NODES[1209].Fix(VELOCITY_X); -NODES[1209].Fix(VELOCITY_Y); -NODES[1209].Fix(VELOCITY_Z); -NODES[1210].Fix(VELOCITY_X); -NODES[1210].Fix(VELOCITY_Y); -NODES[1210].Fix(VELOCITY_Z); -NODES[1211].Fix(VELOCITY_X); -NODES[1211].Fix(VELOCITY_Y); -NODES[1211].Fix(VELOCITY_Z); -NODES[1212].Fix(VELOCITY_X); -NODES[1212].Fix(VELOCITY_Y); -NODES[1212].Fix(VELOCITY_Z); -NODES[1213].Fix(VELOCITY_X); -NODES[1213].Fix(VELOCITY_Y); -NODES[1213].Fix(VELOCITY_Z); -NODES[1214].Fix(VELOCITY_X); -NODES[1214].Fix(VELOCITY_Y); -NODES[1214].Fix(VELOCITY_Z); -NODES[1215].Fix(VELOCITY_X); -NODES[1215].Fix(VELOCITY_Y); -NODES[1215].Fix(VELOCITY_Z); -NODES[1216].Fix(VELOCITY_X); -NODES[1216].Fix(VELOCITY_Y); -NODES[1216].Fix(VELOCITY_Z); -NODES[1217].Fix(VELOCITY_X); -NODES[1217].Fix(VELOCITY_Y); -NODES[1217].Fix(VELOCITY_Z); -NODES[1218].Fix(VELOCITY_X); -NODES[1218].Fix(VELOCITY_Y); -NODES[1218].Fix(VELOCITY_Z); -NODES[1219].Fix(VELOCITY_X); -NODES[1219].Fix(VELOCITY_Y); -NODES[1219].Fix(VELOCITY_Z); -NODES[1220].Fix(VELOCITY_X); -NODES[1220].Fix(VELOCITY_Y); -NODES[1220].Fix(VELOCITY_Z); -NODES[1221].Fix(VELOCITY_X); -NODES[1221].Fix(VELOCITY_Y); -NODES[1221].Fix(VELOCITY_Z); -NODES[1222].Fix(VELOCITY_X); -NODES[1222].Fix(VELOCITY_Y); -NODES[1222].Fix(VELOCITY_Z); -NODES[1223].Fix(VELOCITY_X); -NODES[1223].Fix(VELOCITY_Y); -NODES[1223].Fix(VELOCITY_Z); -NODES[1224].Fix(VELOCITY_X); -NODES[1224].Fix(VELOCITY_Y); -NODES[1224].Fix(VELOCITY_Z); -NODES[1225].Fix(VELOCITY_X); -NODES[1225].Fix(VELOCITY_Y); -NODES[1225].Fix(VELOCITY_Z); -NODES[1226].Fix(VELOCITY_X); -NODES[1226].Fix(VELOCITY_Y); -NODES[1226].Fix(VELOCITY_Z); -NODES[1227].Fix(VELOCITY_X); -NODES[1227].Fix(VELOCITY_Y); -NODES[1227].Fix(VELOCITY_Z); -NODES[1228].Fix(VELOCITY_X); -NODES[1228].Fix(VELOCITY_Y); -NODES[1228].Fix(VELOCITY_Z); -NODES[1229].Fix(VELOCITY_X); -NODES[1229].Fix(VELOCITY_Y); -NODES[1229].Fix(VELOCITY_Z); -NODES[1230].Fix(VELOCITY_X); -NODES[1230].Fix(VELOCITY_Y); -NODES[1230].Fix(VELOCITY_Z); -NODES[1231].Fix(VELOCITY_X); -NODES[1231].Fix(VELOCITY_Y); -NODES[1231].Fix(VELOCITY_Z); -NODES[1232].Fix(VELOCITY_X); -NODES[1232].Fix(VELOCITY_Y); -NODES[1232].Fix(VELOCITY_Z); -NODES[1233].Fix(VELOCITY_X); -NODES[1233].Fix(VELOCITY_Y); -NODES[1233].Fix(VELOCITY_Z); -NODES[1234].Fix(VELOCITY_X); -NODES[1234].Fix(VELOCITY_Y); -NODES[1234].Fix(VELOCITY_Z); -NODES[1235].Fix(VELOCITY_X); -NODES[1235].Fix(VELOCITY_Y); -NODES[1235].Fix(VELOCITY_Z); -NODES[1236].Fix(VELOCITY_X); -NODES[1236].Fix(VELOCITY_Y); -NODES[1236].Fix(VELOCITY_Z); -NODES[1237].Fix(VELOCITY_X); -NODES[1237].Fix(VELOCITY_Y); -NODES[1237].Fix(VELOCITY_Z); -NODES[1238].Fix(VELOCITY_X); -NODES[1238].Fix(VELOCITY_Y); -NODES[1238].Fix(VELOCITY_Z); -NODES[1239].Fix(VELOCITY_X); -NODES[1239].Fix(VELOCITY_Y); -NODES[1239].Fix(VELOCITY_Z); -NODES[1240].Fix(VELOCITY_X); -NODES[1240].Fix(VELOCITY_Y); -NODES[1240].Fix(VELOCITY_Z); -NODES[1241].Fix(VELOCITY_X); -NODES[1241].Fix(VELOCITY_Y); -NODES[1241].Fix(VELOCITY_Z); -NODES[1242].Fix(VELOCITY_X); -NODES[1242].Fix(VELOCITY_Y); -NODES[1242].Fix(VELOCITY_Z); -NODES[1243].Fix(VELOCITY_X); -NODES[1243].Fix(VELOCITY_Y); -NODES[1243].Fix(VELOCITY_Z); -NODES[1244].Fix(VELOCITY_X); -NODES[1244].Fix(VELOCITY_Y); -NODES[1244].Fix(VELOCITY_Z); -NODES[1245].Fix(VELOCITY_X); -NODES[1245].Fix(VELOCITY_Y); -NODES[1245].Fix(VELOCITY_Z); -NODES[1246].Fix(VELOCITY_X); -NODES[1246].Fix(VELOCITY_Y); -NODES[1246].Fix(VELOCITY_Z); -NODES[1247].Fix(VELOCITY_X); -NODES[1247].Fix(VELOCITY_Y); -NODES[1247].Fix(VELOCITY_Z); -NODES[1248].Fix(VELOCITY_X); -NODES[1248].Fix(VELOCITY_Y); -NODES[1248].Fix(VELOCITY_Z); -NODES[1249].Fix(VELOCITY_X); -NODES[1249].Fix(VELOCITY_Y); -NODES[1249].Fix(VELOCITY_Z); -NODES[1250].Fix(VELOCITY_X); -NODES[1250].Fix(VELOCITY_Y); -NODES[1250].Fix(VELOCITY_Z); -NODES[1251].Fix(VELOCITY_X); -NODES[1251].Fix(VELOCITY_Y); -NODES[1251].Fix(VELOCITY_Z); -NODES[1252].Fix(VELOCITY_X); -NODES[1252].Fix(VELOCITY_Y); -NODES[1252].Fix(VELOCITY_Z); -NODES[1253].Fix(VELOCITY_X); -NODES[1253].Fix(VELOCITY_Y); -NODES[1253].Fix(VELOCITY_Z); -NODES[1254].Fix(VELOCITY_X); -NODES[1254].Fix(VELOCITY_Y); -NODES[1254].Fix(VELOCITY_Z); -NODES[1255].Fix(VELOCITY_X); -NODES[1255].Fix(VELOCITY_Y); -NODES[1255].Fix(VELOCITY_Z); -NODES[1256].Fix(VELOCITY_X); -NODES[1256].Fix(VELOCITY_Y); -NODES[1256].Fix(VELOCITY_Z); -NODES[1257].Fix(VELOCITY_X); -NODES[1257].Fix(VELOCITY_Y); -NODES[1257].Fix(VELOCITY_Z); -NODES[1258].Fix(VELOCITY_X); -NODES[1258].Fix(VELOCITY_Y); -NODES[1258].Fix(VELOCITY_Z); -NODES[1259].Fix(VELOCITY_X); -NODES[1259].Fix(VELOCITY_Y); -NODES[1259].Fix(VELOCITY_Z); -NODES[1260].Fix(VELOCITY_X); -NODES[1260].Fix(VELOCITY_Y); -NODES[1260].Fix(VELOCITY_Z); -NODES[1261].Fix(VELOCITY_X); -NODES[1261].Fix(VELOCITY_Y); -NODES[1261].Fix(VELOCITY_Z); -NODES[1262].Fix(VELOCITY_X); -NODES[1262].Fix(VELOCITY_Y); -NODES[1262].Fix(VELOCITY_Z); -NODES[1263].Fix(VELOCITY_X); -NODES[1263].Fix(VELOCITY_Y); -NODES[1263].Fix(VELOCITY_Z); -NODES[1264].Fix(VELOCITY_X); -NODES[1264].Fix(VELOCITY_Y); -NODES[1264].Fix(VELOCITY_Z); -NODES[1265].Fix(VELOCITY_X); -NODES[1265].Fix(VELOCITY_Y); -NODES[1265].Fix(VELOCITY_Z); -NODES[1266].Fix(VELOCITY_X); -NODES[1266].Fix(VELOCITY_Y); -NODES[1266].Fix(VELOCITY_Z); -NODES[1267].Fix(VELOCITY_X); -NODES[1267].Fix(VELOCITY_Y); -NODES[1267].Fix(VELOCITY_Z); -NODES[1268].Fix(VELOCITY_X); -NODES[1268].Fix(VELOCITY_Y); -NODES[1268].Fix(VELOCITY_Z); -NODES[1269].Fix(VELOCITY_X); -NODES[1269].Fix(VELOCITY_Y); -NODES[1269].Fix(VELOCITY_Z); -NODES[1270].Fix(VELOCITY_X); -NODES[1270].Fix(VELOCITY_Y); -NODES[1270].Fix(VELOCITY_Z); -NODES[1271].Fix(VELOCITY_X); -NODES[1271].Fix(VELOCITY_Y); -NODES[1271].Fix(VELOCITY_Z); -NODES[1272].Fix(VELOCITY_X); -NODES[1272].Fix(VELOCITY_Y); -NODES[1272].Fix(VELOCITY_Z); -NODES[1273].Fix(VELOCITY_X); -NODES[1273].Fix(VELOCITY_Y); -NODES[1273].Fix(VELOCITY_Z); -NODES[1274].Fix(VELOCITY_X); -NODES[1274].Fix(VELOCITY_Y); -NODES[1274].Fix(VELOCITY_Z); -NODES[1275].Fix(VELOCITY_X); -NODES[1275].Fix(VELOCITY_Y); -NODES[1275].Fix(VELOCITY_Z); -NODES[1276].Fix(VELOCITY_X); -NODES[1276].Fix(VELOCITY_Y); -NODES[1276].Fix(VELOCITY_Z); -NODES[1277].Fix(VELOCITY_X); -NODES[1277].Fix(VELOCITY_Y); -NODES[1277].Fix(VELOCITY_Z); -NODES[1278].Fix(VELOCITY_X); -NODES[1278].Fix(VELOCITY_Y); -NODES[1278].Fix(VELOCITY_Z); -NODES[1279].Fix(VELOCITY_X); -NODES[1279].Fix(VELOCITY_Y); -NODES[1279].Fix(VELOCITY_Z); -NODES[1280].Fix(VELOCITY_X); -NODES[1280].Fix(VELOCITY_Y); -NODES[1280].Fix(VELOCITY_Z); -NODES[1281].Fix(VELOCITY_X); -NODES[1281].Fix(VELOCITY_Y); -NODES[1281].Fix(VELOCITY_Z); -NODES[1282].Fix(VELOCITY_X); -NODES[1282].Fix(VELOCITY_Y); -NODES[1282].Fix(VELOCITY_Z); -NODES[1283].Fix(VELOCITY_X); -NODES[1283].Fix(VELOCITY_Y); -NODES[1283].Fix(VELOCITY_Z); -NODES[1284].Fix(VELOCITY_X); -NODES[1284].Fix(VELOCITY_Y); -NODES[1284].Fix(VELOCITY_Z); -NODES[1285].Fix(VELOCITY_X); -NODES[1285].Fix(VELOCITY_Y); -NODES[1285].Fix(VELOCITY_Z); -NODES[1286].Fix(VELOCITY_X); -NODES[1286].Fix(VELOCITY_Y); -NODES[1286].Fix(VELOCITY_Z); -NODES[1287].Fix(VELOCITY_X); -NODES[1287].Fix(VELOCITY_Y); -NODES[1287].Fix(VELOCITY_Z); -NODES[1288].Fix(VELOCITY_X); -NODES[1288].Fix(VELOCITY_Y); -NODES[1288].Fix(VELOCITY_Z); -NODES[1289].Fix(VELOCITY_X); -NODES[1289].Fix(VELOCITY_Y); -NODES[1289].Fix(VELOCITY_Z); -NODES[1290].Fix(VELOCITY_X); -NODES[1290].Fix(VELOCITY_Y); -NODES[1290].Fix(VELOCITY_Z); -NODES[1291].Fix(VELOCITY_X); -NODES[1291].Fix(VELOCITY_Y); -NODES[1291].Fix(VELOCITY_Z); -NODES[1292].Fix(VELOCITY_X); -NODES[1292].Fix(VELOCITY_Y); -NODES[1292].Fix(VELOCITY_Z); -NODES[1293].Fix(VELOCITY_X); -NODES[1293].Fix(VELOCITY_Y); -NODES[1293].Fix(VELOCITY_Z); -NODES[1294].Fix(VELOCITY_X); -NODES[1294].Fix(VELOCITY_Y); -NODES[1294].Fix(VELOCITY_Z); -NODES[1295].Fix(VELOCITY_X); -NODES[1295].Fix(VELOCITY_Y); -NODES[1295].Fix(VELOCITY_Z); -NODES[1296].Fix(VELOCITY_X); -NODES[1296].Fix(VELOCITY_Y); -NODES[1296].Fix(VELOCITY_Z); -NODES[1297].Fix(VELOCITY_X); -NODES[1297].Fix(VELOCITY_Y); -NODES[1297].Fix(VELOCITY_Z); -NODES[1298].Fix(VELOCITY_X); -NODES[1298].Fix(VELOCITY_Y); -NODES[1298].Fix(VELOCITY_Z); -NODES[1299].Fix(VELOCITY_X); -NODES[1299].Fix(VELOCITY_Y); -NODES[1299].Fix(VELOCITY_Z); -NODES[1300].Fix(VELOCITY_X); -NODES[1300].Fix(VELOCITY_Y); -NODES[1300].Fix(VELOCITY_Z); -NODES[1301].Fix(VELOCITY_X); -NODES[1301].Fix(VELOCITY_Y); -NODES[1301].Fix(VELOCITY_Z); -NODES[1302].Fix(VELOCITY_X); -NODES[1302].Fix(VELOCITY_Y); -NODES[1302].Fix(VELOCITY_Z); -NODES[1303].Fix(VELOCITY_X); -NODES[1303].Fix(VELOCITY_Y); -NODES[1303].Fix(VELOCITY_Z); -NODES[1304].Fix(VELOCITY_X); -NODES[1304].Fix(VELOCITY_Y); -NODES[1304].Fix(VELOCITY_Z); -NODES[1305].Fix(VELOCITY_X); -NODES[1305].Fix(VELOCITY_Y); -NODES[1305].Fix(VELOCITY_Z); -NODES[1306].Fix(VELOCITY_X); -NODES[1306].Fix(VELOCITY_Y); -NODES[1306].Fix(VELOCITY_Z); -NODES[1307].Fix(VELOCITY_X); -NODES[1307].Fix(VELOCITY_Y); -NODES[1307].Fix(VELOCITY_Z); -NODES[1308].Fix(VELOCITY_X); -NODES[1308].Fix(VELOCITY_Y); -NODES[1308].Fix(VELOCITY_Z); -NODES[1309].Fix(VELOCITY_X); -NODES[1309].Fix(VELOCITY_Y); -NODES[1309].Fix(VELOCITY_Z); -NODES[1310].Fix(VELOCITY_X); -NODES[1310].Fix(VELOCITY_Y); -NODES[1310].Fix(VELOCITY_Z); -NODES[1311].Fix(VELOCITY_X); -NODES[1311].Fix(VELOCITY_Y); -NODES[1311].Fix(VELOCITY_Z); -NODES[1312].Fix(VELOCITY_X); -NODES[1312].Fix(VELOCITY_Y); -NODES[1312].Fix(VELOCITY_Z); -NODES[1313].Fix(VELOCITY_X); -NODES[1313].Fix(VELOCITY_Y); -NODES[1313].Fix(VELOCITY_Z); -NODES[1314].Fix(VELOCITY_X); -NODES[1314].Fix(VELOCITY_Y); -NODES[1314].Fix(VELOCITY_Z); -NODES[1315].Fix(VELOCITY_X); -NODES[1315].Fix(VELOCITY_Y); -NODES[1315].Fix(VELOCITY_Z); -NODES[1316].Fix(VELOCITY_X); -NODES[1316].Fix(VELOCITY_Y); -NODES[1316].Fix(VELOCITY_Z); -NODES[1317].Fix(VELOCITY_X); -NODES[1317].Fix(VELOCITY_Y); -NODES[1317].Fix(VELOCITY_Z); -NODES[1318].Fix(VELOCITY_X); -NODES[1318].Fix(VELOCITY_Y); -NODES[1318].Fix(VELOCITY_Z); -NODES[1319].Fix(VELOCITY_X); -NODES[1319].Fix(VELOCITY_Y); -NODES[1319].Fix(VELOCITY_Z); -NODES[1320].Fix(VELOCITY_X); -NODES[1320].Fix(VELOCITY_Y); -NODES[1320].Fix(VELOCITY_Z); -NODES[1321].Fix(VELOCITY_X); -NODES[1321].Fix(VELOCITY_Y); -NODES[1321].Fix(VELOCITY_Z); -NODES[1322].Fix(VELOCITY_X); -NODES[1322].Fix(VELOCITY_Y); -NODES[1322].Fix(VELOCITY_Z); -NODES[1323].Fix(VELOCITY_X); -NODES[1323].Fix(VELOCITY_Y); -NODES[1323].Fix(VELOCITY_Z); -NODES[1324].Fix(VELOCITY_X); -NODES[1324].Fix(VELOCITY_Y); -NODES[1324].Fix(VELOCITY_Z); -NODES[1325].Fix(VELOCITY_X); -NODES[1325].Fix(VELOCITY_Y); -NODES[1325].Fix(VELOCITY_Z); -NODES[1326].Fix(VELOCITY_X); -NODES[1326].Fix(VELOCITY_Y); -NODES[1326].Fix(VELOCITY_Z); -NODES[1327].Fix(VELOCITY_X); -NODES[1327].Fix(VELOCITY_Y); -NODES[1327].Fix(VELOCITY_Z); -NODES[1328].Fix(VELOCITY_X); -NODES[1328].Fix(VELOCITY_Y); -NODES[1328].Fix(VELOCITY_Z); -NODES[1329].Fix(VELOCITY_X); -NODES[1329].Fix(VELOCITY_Y); -NODES[1329].Fix(VELOCITY_Z); -NODES[1330].Fix(VELOCITY_X); -NODES[1330].Fix(VELOCITY_Y); -NODES[1330].Fix(VELOCITY_Z); -NODES[1331].Fix(VELOCITY_X); -NODES[1331].Fix(VELOCITY_Y); -NODES[1331].Fix(VELOCITY_Z); -NODES[1332].Fix(VELOCITY_X); -NODES[1332].Fix(VELOCITY_Y); -NODES[1332].Fix(VELOCITY_Z); -NODES[1333].Fix(VELOCITY_X); -NODES[1333].Fix(VELOCITY_Y); -NODES[1333].Fix(VELOCITY_Z); -NODES[1334].Fix(VELOCITY_X); -NODES[1334].Fix(VELOCITY_Y); -NODES[1334].Fix(VELOCITY_Z); -NODES[1335].Fix(VELOCITY_X); -NODES[1335].Fix(VELOCITY_Y); -NODES[1335].Fix(VELOCITY_Z); -NODES[1336].Fix(VELOCITY_X); -NODES[1336].Fix(VELOCITY_Y); -NODES[1336].Fix(VELOCITY_Z); -NODES[1337].Fix(VELOCITY_X); -NODES[1337].Fix(VELOCITY_Y); -NODES[1337].Fix(VELOCITY_Z); -NODES[1338].Fix(VELOCITY_X); -NODES[1338].Fix(VELOCITY_Y); -NODES[1338].Fix(VELOCITY_Z); -NODES[1339].Fix(VELOCITY_X); -NODES[1339].Fix(VELOCITY_Y); -NODES[1339].Fix(VELOCITY_Z); -NODES[1340].Fix(VELOCITY_X); -NODES[1340].Fix(VELOCITY_Y); -NODES[1340].Fix(VELOCITY_Z); -NODES[1341].Fix(VELOCITY_X); -NODES[1341].Fix(VELOCITY_Y); -NODES[1341].Fix(VELOCITY_Z); -NODES[1342].Fix(VELOCITY_X); -NODES[1342].Fix(VELOCITY_Y); -NODES[1342].Fix(VELOCITY_Z); -NODES[1343].Fix(VELOCITY_X); -NODES[1343].Fix(VELOCITY_Y); -NODES[1343].Fix(VELOCITY_Z); -NODES[1344].Fix(VELOCITY_X); -NODES[1344].Fix(VELOCITY_Y); -NODES[1344].Fix(VELOCITY_Z); -NODES[1345].Fix(VELOCITY_X); -NODES[1345].Fix(VELOCITY_Y); -NODES[1345].Fix(VELOCITY_Z); -NODES[1346].Fix(VELOCITY_X); -NODES[1346].Fix(VELOCITY_Y); -NODES[1346].Fix(VELOCITY_Z); -NODES[1347].Fix(VELOCITY_X); -NODES[1347].Fix(VELOCITY_Y); -NODES[1347].Fix(VELOCITY_Z); -NODES[1348].Fix(VELOCITY_X); -NODES[1348].Fix(VELOCITY_Y); -NODES[1348].Fix(VELOCITY_Z); -NODES[1349].Fix(VELOCITY_X); -NODES[1349].Fix(VELOCITY_Y); -NODES[1349].Fix(VELOCITY_Z); -NODES[1350].Fix(VELOCITY_X); -NODES[1350].Fix(VELOCITY_Y); -NODES[1350].Fix(VELOCITY_Z); -NODES[1351].Fix(VELOCITY_X); -NODES[1351].Fix(VELOCITY_Y); -NODES[1351].Fix(VELOCITY_Z); -NODES[1352].Fix(VELOCITY_X); -NODES[1352].Fix(VELOCITY_Y); -NODES[1352].Fix(VELOCITY_Z); -NODES[1353].Fix(VELOCITY_X); -NODES[1353].Fix(VELOCITY_Y); -NODES[1353].Fix(VELOCITY_Z); -NODES[1354].Fix(VELOCITY_X); -NODES[1354].Fix(VELOCITY_Y); -NODES[1354].Fix(VELOCITY_Z); -NODES[1355].Fix(VELOCITY_X); -NODES[1355].Fix(VELOCITY_Y); -NODES[1355].Fix(VELOCITY_Z); -NODES[1356].Fix(VELOCITY_X); -NODES[1356].Fix(VELOCITY_Y); -NODES[1356].Fix(VELOCITY_Z); -NODES[1357].Fix(VELOCITY_X); -NODES[1357].Fix(VELOCITY_Y); -NODES[1357].Fix(VELOCITY_Z); -NODES[1358].Fix(VELOCITY_X); -NODES[1358].Fix(VELOCITY_Y); -NODES[1358].Fix(VELOCITY_Z); -NODES[1359].Fix(VELOCITY_X); -NODES[1359].Fix(VELOCITY_Y); -NODES[1359].Fix(VELOCITY_Z); -NODES[1360].Fix(VELOCITY_X); -NODES[1360].Fix(VELOCITY_Y); -NODES[1360].Fix(VELOCITY_Z); -NODES[1361].Fix(VELOCITY_X); -NODES[1361].Fix(VELOCITY_Y); -NODES[1361].Fix(VELOCITY_Z); -NODES[1362].Fix(VELOCITY_X); -NODES[1362].Fix(VELOCITY_Y); -NODES[1362].Fix(VELOCITY_Z); -NODES[1363].Fix(VELOCITY_X); -NODES[1363].Fix(VELOCITY_Y); -NODES[1363].Fix(VELOCITY_Z); -NODES[1364].Fix(VELOCITY_X); -NODES[1364].Fix(VELOCITY_Y); -NODES[1364].Fix(VELOCITY_Z); -NODES[1365].Fix(VELOCITY_X); -NODES[1365].Fix(VELOCITY_Y); -NODES[1365].Fix(VELOCITY_Z); -NODES[1366].Fix(VELOCITY_X); -NODES[1366].Fix(VELOCITY_Y); -NODES[1366].Fix(VELOCITY_Z); -NODES[1367].Fix(VELOCITY_X); -NODES[1367].Fix(VELOCITY_Y); -NODES[1367].Fix(VELOCITY_Z); -NODES[1368].Fix(VELOCITY_X); -NODES[1368].Fix(VELOCITY_Y); -NODES[1368].Fix(VELOCITY_Z); -NODES[1369].Fix(VELOCITY_X); -NODES[1369].Fix(VELOCITY_Y); -NODES[1369].Fix(VELOCITY_Z); -NODES[1370].Fix(VELOCITY_X); -NODES[1370].Fix(VELOCITY_Y); -NODES[1370].Fix(VELOCITY_Z); -NODES[1371].Fix(VELOCITY_X); -NODES[1371].Fix(VELOCITY_Y); -NODES[1371].Fix(VELOCITY_Z); -NODES[1372].Fix(VELOCITY_X); -NODES[1372].Fix(VELOCITY_Y); -NODES[1372].Fix(VELOCITY_Z); -NODES[1373].Fix(VELOCITY_X); -NODES[1373].Fix(VELOCITY_Y); -NODES[1373].Fix(VELOCITY_Z); -NODES[1374].Fix(VELOCITY_X); -NODES[1374].Fix(VELOCITY_Y); -NODES[1374].Fix(VELOCITY_Z); -NODES[1375].Fix(VELOCITY_X); -NODES[1375].Fix(VELOCITY_Y); -NODES[1375].Fix(VELOCITY_Z); -NODES[1376].Fix(VELOCITY_X); -NODES[1376].Fix(VELOCITY_Y); -NODES[1376].Fix(VELOCITY_Z); -NODES[1377].Fix(VELOCITY_X); -NODES[1377].Fix(VELOCITY_Y); -NODES[1377].Fix(VELOCITY_Z); -NODES[1378].Fix(VELOCITY_X); -NODES[1378].Fix(VELOCITY_Y); -NODES[1378].Fix(VELOCITY_Z); -NODES[1379].Fix(VELOCITY_X); -NODES[1379].Fix(VELOCITY_Y); -NODES[1379].Fix(VELOCITY_Z); -NODES[1380].Fix(VELOCITY_X); -NODES[1380].Fix(VELOCITY_Y); -NODES[1380].Fix(VELOCITY_Z); -NODES[1381].Fix(VELOCITY_X); -NODES[1381].Fix(VELOCITY_Y); -NODES[1381].Fix(VELOCITY_Z); -NODES[1382].Fix(VELOCITY_X); -NODES[1382].Fix(VELOCITY_Y); -NODES[1382].Fix(VELOCITY_Z); -NODES[1383].Fix(VELOCITY_X); -NODES[1383].Fix(VELOCITY_Y); -NODES[1383].Fix(VELOCITY_Z); -NODES[1384].Fix(VELOCITY_X); -NODES[1384].Fix(VELOCITY_Y); -NODES[1384].Fix(VELOCITY_Z); -NODES[1385].Fix(VELOCITY_X); -NODES[1385].Fix(VELOCITY_Y); -NODES[1385].Fix(VELOCITY_Z); -NODES[1386].Fix(VELOCITY_X); -NODES[1386].Fix(VELOCITY_Y); -NODES[1386].Fix(VELOCITY_Z); -NODES[1387].Fix(VELOCITY_X); -NODES[1387].Fix(VELOCITY_Y); -NODES[1387].Fix(VELOCITY_Z); -NODES[1388].Fix(VELOCITY_X); -NODES[1388].Fix(VELOCITY_Y); -NODES[1388].Fix(VELOCITY_Z); -NODES[1389].Fix(VELOCITY_X); -NODES[1389].Fix(VELOCITY_Y); -NODES[1389].Fix(VELOCITY_Z); -NODES[1390].Fix(VELOCITY_X); -NODES[1390].Fix(VELOCITY_Y); -NODES[1390].Fix(VELOCITY_Z); -NODES[1391].Fix(VELOCITY_X); -NODES[1391].Fix(VELOCITY_Y); -NODES[1391].Fix(VELOCITY_Z); -NODES[1392].Fix(VELOCITY_X); -NODES[1392].Fix(VELOCITY_Y); -NODES[1392].Fix(VELOCITY_Z); -NODES[1393].Fix(VELOCITY_X); -NODES[1393].Fix(VELOCITY_Y); -NODES[1393].Fix(VELOCITY_Z); -NODES[1394].Fix(VELOCITY_X); -NODES[1394].Fix(VELOCITY_Y); -NODES[1394].Fix(VELOCITY_Z); -NODES[1395].Fix(VELOCITY_X); -NODES[1395].Fix(VELOCITY_Y); -NODES[1395].Fix(VELOCITY_Z); -NODES[1396].Fix(VELOCITY_X); -NODES[1396].Fix(VELOCITY_Y); -NODES[1396].Fix(VELOCITY_Z); -NODES[1397].Fix(VELOCITY_X); -NODES[1397].Fix(VELOCITY_Y); -NODES[1397].Fix(VELOCITY_Z); -NODES[1398].Fix(VELOCITY_X); -NODES[1398].Fix(VELOCITY_Y); -NODES[1398].Fix(VELOCITY_Z); -NODES[1399].Fix(VELOCITY_X); -NODES[1399].Fix(VELOCITY_Y); -NODES[1399].Fix(VELOCITY_Z); -NODES[1400].Fix(VELOCITY_X); -NODES[1400].Fix(VELOCITY_Y); -NODES[1400].Fix(VELOCITY_Z); -NODES[1401].Fix(VELOCITY_X); -NODES[1401].Fix(VELOCITY_Y); -NODES[1401].Fix(VELOCITY_Z); -NODES[1402].Fix(VELOCITY_X); -NODES[1402].Fix(VELOCITY_Y); -NODES[1402].Fix(VELOCITY_Z); -NODES[1403].Fix(VELOCITY_X); -NODES[1403].Fix(VELOCITY_Y); -NODES[1403].Fix(VELOCITY_Z); -NODES[1404].Fix(VELOCITY_X); -NODES[1404].Fix(VELOCITY_Y); -NODES[1404].Fix(VELOCITY_Z); -NODES[1405].Fix(VELOCITY_X); -NODES[1405].Fix(VELOCITY_Y); -NODES[1405].Fix(VELOCITY_Z); -NODES[1406].Fix(VELOCITY_X); -NODES[1406].Fix(VELOCITY_Y); -NODES[1406].Fix(VELOCITY_Z); -NODES[1407].Fix(VELOCITY_X); -NODES[1407].Fix(VELOCITY_Y); -NODES[1407].Fix(VELOCITY_Z); -NODES[1408].Fix(VELOCITY_X); -NODES[1408].Fix(VELOCITY_Y); -NODES[1408].Fix(VELOCITY_Z); -NODES[1409].Fix(VELOCITY_X); -NODES[1409].Fix(VELOCITY_Y); -NODES[1409].Fix(VELOCITY_Z); -NODES[1410].Fix(VELOCITY_X); -NODES[1410].Fix(VELOCITY_Y); -NODES[1410].Fix(VELOCITY_Z); -NODES[1411].Fix(VELOCITY_X); -NODES[1411].Fix(VELOCITY_Y); -NODES[1411].Fix(VELOCITY_Z); -NODES[1412].Fix(VELOCITY_X); -NODES[1412].Fix(VELOCITY_Y); -NODES[1412].Fix(VELOCITY_Z); -NODES[1413].Fix(VELOCITY_X); -NODES[1413].Fix(VELOCITY_Y); -NODES[1413].Fix(VELOCITY_Z); -NODES[1414].Fix(VELOCITY_X); -NODES[1414].Fix(VELOCITY_Y); -NODES[1414].Fix(VELOCITY_Z); -NODES[1415].Fix(VELOCITY_X); -NODES[1415].Fix(VELOCITY_Y); -NODES[1415].Fix(VELOCITY_Z); -NODES[1416].Fix(VELOCITY_X); -NODES[1416].Fix(VELOCITY_Y); -NODES[1416].Fix(VELOCITY_Z); -NODES[1417].Fix(VELOCITY_X); -NODES[1417].Fix(VELOCITY_Y); -NODES[1417].Fix(VELOCITY_Z); -NODES[1418].Fix(VELOCITY_X); -NODES[1418].Fix(VELOCITY_Y); -NODES[1418].Fix(VELOCITY_Z); -NODES[1419].Fix(VELOCITY_X); -NODES[1419].Fix(VELOCITY_Y); -NODES[1419].Fix(VELOCITY_Z); -NODES[1420].Fix(VELOCITY_X); -NODES[1420].Fix(VELOCITY_Y); -NODES[1420].Fix(VELOCITY_Z); -NODES[1421].Fix(VELOCITY_X); -NODES[1421].Fix(VELOCITY_Y); -NODES[1421].Fix(VELOCITY_Z); -NODES[1422].Fix(VELOCITY_X); -NODES[1422].Fix(VELOCITY_Y); -NODES[1422].Fix(VELOCITY_Z); -NODES[1423].Fix(VELOCITY_X); -NODES[1423].Fix(VELOCITY_Y); -NODES[1423].Fix(VELOCITY_Z); -NODES[1424].Fix(VELOCITY_X); -NODES[1424].Fix(VELOCITY_Y); -NODES[1424].Fix(VELOCITY_Z); -NODES[1425].Fix(VELOCITY_X); -NODES[1425].Fix(VELOCITY_Y); -NODES[1425].Fix(VELOCITY_Z); -NODES[1426].Fix(VELOCITY_X); -NODES[1426].Fix(VELOCITY_Y); -NODES[1426].Fix(VELOCITY_Z); -NODES[1427].Fix(VELOCITY_X); -NODES[1427].Fix(VELOCITY_Y); -NODES[1427].Fix(VELOCITY_Z); -NODES[1428].Fix(VELOCITY_X); -NODES[1428].Fix(VELOCITY_Y); -NODES[1428].Fix(VELOCITY_Z); -NODES[1429].Fix(VELOCITY_X); -NODES[1429].Fix(VELOCITY_Y); -NODES[1429].Fix(VELOCITY_Z); -NODES[1430].Fix(VELOCITY_X); -NODES[1430].Fix(VELOCITY_Y); -NODES[1430].Fix(VELOCITY_Z); -NODES[1431].Fix(VELOCITY_X); -NODES[1431].Fix(VELOCITY_Y); -NODES[1431].Fix(VELOCITY_Z); -NODES[1432].Fix(VELOCITY_X); -NODES[1432].Fix(VELOCITY_Y); -NODES[1432].Fix(VELOCITY_Z); -NODES[1433].Fix(VELOCITY_X); -NODES[1433].Fix(VELOCITY_Y); -NODES[1433].Fix(VELOCITY_Z); -NODES[1434].Fix(VELOCITY_X); -NODES[1434].Fix(VELOCITY_Y); -NODES[1434].Fix(VELOCITY_Z); -NODES[1435].Fix(VELOCITY_X); -NODES[1435].Fix(VELOCITY_Y); -NODES[1435].Fix(VELOCITY_Z); -NODES[1436].Fix(VELOCITY_X); -NODES[1436].Fix(VELOCITY_Y); -NODES[1436].Fix(VELOCITY_Z); -NODES[1437].Fix(VELOCITY_X); -NODES[1437].Fix(VELOCITY_Y); -NODES[1437].Fix(VELOCITY_Z); -NODES[1438].Fix(VELOCITY_X); -NODES[1438].Fix(VELOCITY_Y); -NODES[1438].Fix(VELOCITY_Z); -NODES[1439].Fix(VELOCITY_X); -NODES[1439].Fix(VELOCITY_Y); -NODES[1439].Fix(VELOCITY_Z); -NODES[1440].Fix(VELOCITY_X); -NODES[1440].Fix(VELOCITY_Y); -NODES[1440].Fix(VELOCITY_Z); -NODES[1441].Fix(VELOCITY_X); -NODES[1441].Fix(VELOCITY_Y); -NODES[1441].Fix(VELOCITY_Z); -NODES[1442].Fix(VELOCITY_X); -NODES[1442].Fix(VELOCITY_Y); -NODES[1442].Fix(VELOCITY_Z); -NODES[1443].Fix(VELOCITY_X); -NODES[1443].Fix(VELOCITY_Y); -NODES[1443].Fix(VELOCITY_Z); -NODES[1444].Fix(VELOCITY_X); -NODES[1444].Fix(VELOCITY_Y); -NODES[1444].Fix(VELOCITY_Z); -NODES[1445].Fix(VELOCITY_X); -NODES[1445].Fix(VELOCITY_Y); -NODES[1445].Fix(VELOCITY_Z); -NODES[1446].Fix(VELOCITY_X); -NODES[1446].Fix(VELOCITY_Y); -NODES[1446].Fix(VELOCITY_Z); -NODES[1447].Fix(VELOCITY_X); -NODES[1447].Fix(VELOCITY_Y); -NODES[1447].Fix(VELOCITY_Z); -NODES[1448].Fix(VELOCITY_X); -NODES[1448].Fix(VELOCITY_Y); -NODES[1448].Fix(VELOCITY_Z); -NODES[1449].Fix(VELOCITY_X); -NODES[1449].Fix(VELOCITY_Y); -NODES[1449].Fix(VELOCITY_Z); -NODES[1450].Fix(VELOCITY_X); -NODES[1450].Fix(VELOCITY_Y); -NODES[1450].Fix(VELOCITY_Z); -NODES[1451].Fix(VELOCITY_X); -NODES[1451].Fix(VELOCITY_Y); -NODES[1451].Fix(VELOCITY_Z); -NODES[1452].Fix(VELOCITY_X); -NODES[1452].Fix(VELOCITY_Y); -NODES[1452].Fix(VELOCITY_Z); -NODES[1453].Fix(VELOCITY_X); -NODES[1453].Fix(VELOCITY_Y); -NODES[1453].Fix(VELOCITY_Z); -NODES[1454].Fix(VELOCITY_X); -NODES[1454].Fix(VELOCITY_Y); -NODES[1454].Fix(VELOCITY_Z); -NODES[1455].Fix(VELOCITY_X); -NODES[1455].Fix(VELOCITY_Y); -NODES[1455].Fix(VELOCITY_Z); -NODES[1456].Fix(VELOCITY_X); -NODES[1456].Fix(VELOCITY_Y); -NODES[1456].Fix(VELOCITY_Z); -NODES[1457].Fix(VELOCITY_X); -NODES[1457].Fix(VELOCITY_Y); -NODES[1457].Fix(VELOCITY_Z); -NODES[1458].Fix(VELOCITY_X); -NODES[1458].Fix(VELOCITY_Y); -NODES[1458].Fix(VELOCITY_Z); -NODES[1459].Fix(VELOCITY_X); -NODES[1459].Fix(VELOCITY_Y); -NODES[1459].Fix(VELOCITY_Z); -NODES[1460].Fix(VELOCITY_X); -NODES[1460].Fix(VELOCITY_Y); -NODES[1460].Fix(VELOCITY_Z); -NODES[1461].Fix(VELOCITY_X); -NODES[1461].Fix(VELOCITY_Y); -NODES[1461].Fix(VELOCITY_Z); -NODES[1462].Fix(VELOCITY_X); -NODES[1462].Fix(VELOCITY_Y); -NODES[1462].Fix(VELOCITY_Z); -NODES[1463].Fix(VELOCITY_X); -NODES[1463].Fix(VELOCITY_Y); -NODES[1463].Fix(VELOCITY_Z); -NODES[1464].Fix(VELOCITY_X); -NODES[1464].Fix(VELOCITY_Y); -NODES[1464].Fix(VELOCITY_Z); -NODES[1465].Fix(VELOCITY_X); -NODES[1465].Fix(VELOCITY_Y); -NODES[1465].Fix(VELOCITY_Z); -NODES[1466].Fix(VELOCITY_X); -NODES[1466].Fix(VELOCITY_Y); -NODES[1466].Fix(VELOCITY_Z); -NODES[1467].Fix(VELOCITY_X); -NODES[1467].Fix(VELOCITY_Y); -NODES[1467].Fix(VELOCITY_Z); -NODES[1468].Fix(VELOCITY_X); -NODES[1468].Fix(VELOCITY_Y); -NODES[1468].Fix(VELOCITY_Z); -NODES[1469].Fix(VELOCITY_X); -NODES[1469].Fix(VELOCITY_Y); -NODES[1469].Fix(VELOCITY_Z); -NODES[1470].Fix(VELOCITY_X); -NODES[1470].Fix(VELOCITY_Y); -NODES[1470].Fix(VELOCITY_Z); -NODES[1471].Fix(VELOCITY_X); -NODES[1471].Fix(VELOCITY_Y); -NODES[1471].Fix(VELOCITY_Z); -NODES[1472].Fix(VELOCITY_X); -NODES[1472].Fix(VELOCITY_Y); -NODES[1472].Fix(VELOCITY_Z); -NODES[1473].Fix(VELOCITY_X); -NODES[1473].Fix(VELOCITY_Y); -NODES[1473].Fix(VELOCITY_Z); -NODES[1474].Fix(VELOCITY_X); -NODES[1474].Fix(VELOCITY_Y); -NODES[1474].Fix(VELOCITY_Z); -NODES[1475].Fix(VELOCITY_X); -NODES[1475].Fix(VELOCITY_Y); -NODES[1475].Fix(VELOCITY_Z); -NODES[1476].Fix(VELOCITY_X); -NODES[1476].Fix(VELOCITY_Y); -NODES[1476].Fix(VELOCITY_Z); -NODES[1477].Fix(VELOCITY_X); -NODES[1477].Fix(VELOCITY_Y); -NODES[1477].Fix(VELOCITY_Z); -NODES[1478].Fix(VELOCITY_X); -NODES[1478].Fix(VELOCITY_Y); -NODES[1478].Fix(VELOCITY_Z); -NODES[1479].Fix(VELOCITY_X); -NODES[1479].Fix(VELOCITY_Y); -NODES[1479].Fix(VELOCITY_Z); -NODES[1480].Fix(VELOCITY_X); -NODES[1480].Fix(VELOCITY_Y); -NODES[1480].Fix(VELOCITY_Z); -NODES[1481].Fix(VELOCITY_X); -NODES[1481].Fix(VELOCITY_Y); -NODES[1481].Fix(VELOCITY_Z); -NODES[1482].Fix(VELOCITY_X); -NODES[1482].Fix(VELOCITY_Y); -NODES[1482].Fix(VELOCITY_Z); -NODES[1483].Fix(VELOCITY_X); -NODES[1483].Fix(VELOCITY_Y); -NODES[1483].Fix(VELOCITY_Z); -NODES[1484].Fix(VELOCITY_X); -NODES[1484].Fix(VELOCITY_Y); -NODES[1484].Fix(VELOCITY_Z); -NODES[1485].Fix(VELOCITY_X); -NODES[1485].Fix(VELOCITY_Y); -NODES[1485].Fix(VELOCITY_Z); -NODES[1486].Fix(VELOCITY_X); -NODES[1486].Fix(VELOCITY_Y); -NODES[1486].Fix(VELOCITY_Z); -NODES[1487].Fix(VELOCITY_X); -NODES[1487].Fix(VELOCITY_Y); -NODES[1487].Fix(VELOCITY_Z); -NODES[1488].Fix(VELOCITY_X); -NODES[1488].Fix(VELOCITY_Y); -NODES[1488].Fix(VELOCITY_Z); -NODES[1489].Fix(VELOCITY_X); -NODES[1489].Fix(VELOCITY_Y); -NODES[1489].Fix(VELOCITY_Z); -NODES[1490].Fix(VELOCITY_X); -NODES[1490].Fix(VELOCITY_Y); -NODES[1490].Fix(VELOCITY_Z); -NODES[1491].Fix(VELOCITY_X); -NODES[1491].Fix(VELOCITY_Y); -NODES[1491].Fix(VELOCITY_Z); -NODES[1492].Fix(VELOCITY_X); -NODES[1492].Fix(VELOCITY_Y); -NODES[1492].Fix(VELOCITY_Z); -NODES[1493].Fix(VELOCITY_X); -NODES[1493].Fix(VELOCITY_Y); -NODES[1493].Fix(VELOCITY_Z); -NODES[1494].Fix(VELOCITY_X); -NODES[1494].Fix(VELOCITY_Y); -NODES[1494].Fix(VELOCITY_Z); -NODES[1495].Fix(VELOCITY_X); -NODES[1495].Fix(VELOCITY_Y); -NODES[1495].Fix(VELOCITY_Z); -NODES[1496].Fix(VELOCITY_X); -NODES[1496].Fix(VELOCITY_Y); -NODES[1496].Fix(VELOCITY_Z); -NODES[1497].Fix(VELOCITY_X); -NODES[1497].Fix(VELOCITY_Y); -NODES[1497].Fix(VELOCITY_Z); -NODES[1498].Fix(VELOCITY_X); -NODES[1498].Fix(VELOCITY_Y); -NODES[1498].Fix(VELOCITY_Z); -NODES[1499].Fix(VELOCITY_X); -NODES[1499].Fix(VELOCITY_Y); -NODES[1499].Fix(VELOCITY_Z); -NODES[1500].Fix(VELOCITY_X); -NODES[1500].Fix(VELOCITY_Y); -NODES[1500].Fix(VELOCITY_Z); -NODES[1501].Fix(VELOCITY_X); -NODES[1501].Fix(VELOCITY_Y); -NODES[1501].Fix(VELOCITY_Z); -NODES[1502].Fix(VELOCITY_X); -NODES[1502].Fix(VELOCITY_Y); -NODES[1502].Fix(VELOCITY_Z); -NODES[1503].Fix(VELOCITY_X); -NODES[1503].Fix(VELOCITY_Y); -NODES[1503].Fix(VELOCITY_Z); -NODES[1504].Fix(VELOCITY_X); -NODES[1504].Fix(VELOCITY_Y); -NODES[1504].Fix(VELOCITY_Z); -NODES[1505].Fix(VELOCITY_X); -NODES[1505].Fix(VELOCITY_Y); -NODES[1505].Fix(VELOCITY_Z); -NODES[1506].Fix(VELOCITY_X); -NODES[1506].Fix(VELOCITY_Y); -NODES[1506].Fix(VELOCITY_Z); -NODES[1507].Fix(VELOCITY_X); -NODES[1507].Fix(VELOCITY_Y); -NODES[1507].Fix(VELOCITY_Z); -NODES[1508].Fix(VELOCITY_X); -NODES[1508].Fix(VELOCITY_Y); -NODES[1508].Fix(VELOCITY_Z); -NODES[1509].Fix(VELOCITY_X); -NODES[1509].Fix(VELOCITY_Y); -NODES[1509].Fix(VELOCITY_Z); -NODES[1510].Fix(VELOCITY_X); -NODES[1510].Fix(VELOCITY_Y); -NODES[1510].Fix(VELOCITY_Z); -NODES[1511].Fix(VELOCITY_X); -NODES[1511].Fix(VELOCITY_Y); -NODES[1511].Fix(VELOCITY_Z); -NODES[1512].Fix(VELOCITY_X); -NODES[1512].Fix(VELOCITY_Y); -NODES[1512].Fix(VELOCITY_Z); -NODES[1513].Fix(VELOCITY_X); -NODES[1513].Fix(VELOCITY_Y); -NODES[1513].Fix(VELOCITY_Z); -NODES[1514].Fix(VELOCITY_X); -NODES[1514].Fix(VELOCITY_Y); -NODES[1514].Fix(VELOCITY_Z); -NODES[1515].Fix(VELOCITY_X); -NODES[1515].Fix(VELOCITY_Y); -NODES[1515].Fix(VELOCITY_Z); -NODES[1516].Fix(VELOCITY_X); -NODES[1516].Fix(VELOCITY_Y); -NODES[1516].Fix(VELOCITY_Z); -NODES[1517].Fix(VELOCITY_X); -NODES[1517].Fix(VELOCITY_Y); -NODES[1517].Fix(VELOCITY_Z); -NODES[1518].Fix(VELOCITY_X); -NODES[1518].Fix(VELOCITY_Y); -NODES[1518].Fix(VELOCITY_Z); -NODES[1519].Fix(VELOCITY_X); -NODES[1519].Fix(VELOCITY_Y); -NODES[1519].Fix(VELOCITY_Z); -NODES[1520].Fix(VELOCITY_X); -NODES[1520].Fix(VELOCITY_Y); -NODES[1520].Fix(VELOCITY_Z); -NODES[1521].Fix(VELOCITY_X); -NODES[1521].Fix(VELOCITY_Y); -NODES[1521].Fix(VELOCITY_Z); -NODES[1522].Fix(VELOCITY_X); -NODES[1522].Fix(VELOCITY_Y); -NODES[1522].Fix(VELOCITY_Z); -NODES[1523].Fix(VELOCITY_X); -NODES[1523].Fix(VELOCITY_Y); -NODES[1523].Fix(VELOCITY_Z); -NODES[1524].Fix(VELOCITY_X); -NODES[1524].Fix(VELOCITY_Y); -NODES[1524].Fix(VELOCITY_Z); -NODES[1525].Fix(VELOCITY_X); -NODES[1525].Fix(VELOCITY_Y); -NODES[1525].Fix(VELOCITY_Z); -NODES[1526].Fix(VELOCITY_X); -NODES[1526].Fix(VELOCITY_Y); -NODES[1526].Fix(VELOCITY_Z); -NODES[1527].Fix(VELOCITY_X); -NODES[1527].Fix(VELOCITY_Y); -NODES[1527].Fix(VELOCITY_Z); -NODES[1528].Fix(VELOCITY_X); -NODES[1528].Fix(VELOCITY_Y); -NODES[1528].Fix(VELOCITY_Z); -NODES[1529].Fix(VELOCITY_X); -NODES[1529].Fix(VELOCITY_Y); -NODES[1529].Fix(VELOCITY_Z); -NODES[1530].Fix(VELOCITY_X); -NODES[1530].Fix(VELOCITY_Y); -NODES[1530].Fix(VELOCITY_Z); -NODES[1531].Fix(VELOCITY_X); -NODES[1531].Fix(VELOCITY_Y); -NODES[1531].Fix(VELOCITY_Z); -NODES[1532].Fix(VELOCITY_X); -NODES[1532].Fix(VELOCITY_Y); -NODES[1532].Fix(VELOCITY_Z); -NODES[1533].Fix(VELOCITY_X); -NODES[1533].Fix(VELOCITY_Y); -NODES[1533].Fix(VELOCITY_Z); -NODES[1534].Fix(VELOCITY_X); -NODES[1534].Fix(VELOCITY_Y); -NODES[1534].Fix(VELOCITY_Z); -NODES[1535].Fix(VELOCITY_X); -NODES[1535].Fix(VELOCITY_Y); -NODES[1535].Fix(VELOCITY_Z); -NODES[1536].Fix(VELOCITY_X); -NODES[1536].Fix(VELOCITY_Y); -NODES[1536].Fix(VELOCITY_Z); -NODES[1537].Fix(VELOCITY_X); -NODES[1537].Fix(VELOCITY_Y); -NODES[1537].Fix(VELOCITY_Z); -NODES[1538].Fix(VELOCITY_X); -NODES[1538].Fix(VELOCITY_Y); -NODES[1538].Fix(VELOCITY_Z); -NODES[1539].Fix(VELOCITY_X); -NODES[1539].Fix(VELOCITY_Y); -NODES[1539].Fix(VELOCITY_Z); -NODES[1540].Fix(VELOCITY_X); -NODES[1540].Fix(VELOCITY_Y); -NODES[1540].Fix(VELOCITY_Z); -NODES[1541].Fix(VELOCITY_X); -NODES[1541].Fix(VELOCITY_Y); -NODES[1541].Fix(VELOCITY_Z); -NODES[1542].Fix(VELOCITY_X); -NODES[1542].Fix(VELOCITY_Y); -NODES[1542].Fix(VELOCITY_Z); -NODES[1544].Fix(VELOCITY_X); -NODES[1544].Fix(VELOCITY_Y); -NODES[1544].Fix(VELOCITY_Z); -NODES[1545].Fix(VELOCITY_X); -NODES[1545].Fix(VELOCITY_Y); -NODES[1545].Fix(VELOCITY_Z); -NODES[1547].Fix(VELOCITY_X); -NODES[1547].Fix(VELOCITY_Y); -NODES[1547].Fix(VELOCITY_Z); -NODES[1548].Fix(VELOCITY_X); -NODES[1548].Fix(VELOCITY_Y); -NODES[1548].Fix(VELOCITY_Z); -NODES[1549].Fix(VELOCITY_X); -NODES[1549].Fix(VELOCITY_Y); -NODES[1549].Fix(VELOCITY_Z); -NODES[1550].Fix(VELOCITY_X); -NODES[1550].Fix(VELOCITY_Y); -NODES[1550].Fix(VELOCITY_Z); -NODES[1551].Fix(VELOCITY_X); -NODES[1551].Fix(VELOCITY_Y); -NODES[1551].Fix(VELOCITY_Z); -NODES[1552].Fix(VELOCITY_X); -NODES[1552].Fix(VELOCITY_Y); -NODES[1552].Fix(VELOCITY_Z); -NODES[1554].Fix(VELOCITY_X); -NODES[1554].Fix(VELOCITY_Y); -NODES[1554].Fix(VELOCITY_Z); -NODES[1555].Fix(VELOCITY_X); -NODES[1555].Fix(VELOCITY_Y); -NODES[1555].Fix(VELOCITY_Z); -NODES[1556].Fix(VELOCITY_X); -NODES[1556].Fix(VELOCITY_Y); -NODES[1556].Fix(VELOCITY_Z); -NODES[1557].Fix(VELOCITY_X); -NODES[1557].Fix(VELOCITY_Y); -NODES[1557].Fix(VELOCITY_Z); -NODES[1558].Fix(VELOCITY_X); -NODES[1558].Fix(VELOCITY_Y); -NODES[1558].Fix(VELOCITY_Z); -NODES[1559].Fix(VELOCITY_X); -NODES[1559].Fix(VELOCITY_Y); -NODES[1559].Fix(VELOCITY_Z); -NODES[1560].Fix(VELOCITY_X); -NODES[1560].Fix(VELOCITY_Y); -NODES[1560].Fix(VELOCITY_Z); -NODES[1561].Fix(VELOCITY_X); -NODES[1561].Fix(VELOCITY_Y); -NODES[1561].Fix(VELOCITY_Z); -NODES[1562].Fix(VELOCITY_X); -NODES[1562].Fix(VELOCITY_Y); -NODES[1562].Fix(VELOCITY_Z); -NODES[1564].Fix(VELOCITY_X); -NODES[1564].Fix(VELOCITY_Y); -NODES[1564].Fix(VELOCITY_Z); -NODES[1565].Fix(VELOCITY_X); -NODES[1565].Fix(VELOCITY_Y); -NODES[1565].Fix(VELOCITY_Z); -NODES[1566].Fix(VELOCITY_X); -NODES[1566].Fix(VELOCITY_Y); -NODES[1566].Fix(VELOCITY_Z); -NODES[1567].Fix(VELOCITY_X); -NODES[1567].Fix(VELOCITY_Y); -NODES[1567].Fix(VELOCITY_Z); -NODES[1568].Fix(VELOCITY_X); -NODES[1568].Fix(VELOCITY_Y); -NODES[1568].Fix(VELOCITY_Z); -NODES[1569].Fix(VELOCITY_X); -NODES[1569].Fix(VELOCITY_Y); -NODES[1569].Fix(VELOCITY_Z); -NODES[1570].Fix(VELOCITY_X); -NODES[1570].Fix(VELOCITY_Y); -NODES[1570].Fix(VELOCITY_Z); -NODES[1571].Fix(VELOCITY_X); -NODES[1571].Fix(VELOCITY_Y); -NODES[1571].Fix(VELOCITY_Z); -NODES[1572].Fix(VELOCITY_X); -NODES[1572].Fix(VELOCITY_Y); -NODES[1572].Fix(VELOCITY_Z); -NODES[1573].Fix(VELOCITY_X); -NODES[1573].Fix(VELOCITY_Y); -NODES[1573].Fix(VELOCITY_Z); -NODES[1574].Fix(VELOCITY_X); -NODES[1574].Fix(VELOCITY_Y); -NODES[1574].Fix(VELOCITY_Z); -NODES[1576].Fix(VELOCITY_X); -NODES[1576].Fix(VELOCITY_Y); -NODES[1576].Fix(VELOCITY_Z); -NODES[1577].Fix(VELOCITY_X); -NODES[1577].Fix(VELOCITY_Y); -NODES[1577].Fix(VELOCITY_Z); -NODES[1578].Fix(VELOCITY_X); -NODES[1578].Fix(VELOCITY_Y); -NODES[1578].Fix(VELOCITY_Z); -NODES[1579].Fix(VELOCITY_X); -NODES[1579].Fix(VELOCITY_Y); -NODES[1579].Fix(VELOCITY_Z); -NODES[1580].Fix(VELOCITY_X); -NODES[1580].Fix(VELOCITY_Y); -NODES[1580].Fix(VELOCITY_Z); -NODES[1581].Fix(VELOCITY_X); -NODES[1581].Fix(VELOCITY_Y); -NODES[1581].Fix(VELOCITY_Z); -NODES[1582].Fix(VELOCITY_X); -NODES[1582].Fix(VELOCITY_Y); -NODES[1582].Fix(VELOCITY_Z); -NODES[1583].Fix(VELOCITY_X); -NODES[1583].Fix(VELOCITY_Y); -NODES[1583].Fix(VELOCITY_Z); -NODES[1584].Fix(VELOCITY_X); -NODES[1584].Fix(VELOCITY_Y); -NODES[1584].Fix(VELOCITY_Z); -NODES[1585].Fix(VELOCITY_X); -NODES[1585].Fix(VELOCITY_Y); -NODES[1585].Fix(VELOCITY_Z); -NODES[1586].Fix(VELOCITY_X); -NODES[1586].Fix(VELOCITY_Y); -NODES[1586].Fix(VELOCITY_Z); -NODES[1587].Fix(VELOCITY_X); -NODES[1587].Fix(VELOCITY_Y); -NODES[1587].Fix(VELOCITY_Z); -NODES[1588].Fix(VELOCITY_X); -NODES[1588].Fix(VELOCITY_Y); -NODES[1588].Fix(VELOCITY_Z); -NODES[1589].Fix(VELOCITY_X); -NODES[1589].Fix(VELOCITY_Y); -NODES[1589].Fix(VELOCITY_Z); -NODES[1590].Fix(VELOCITY_X); -NODES[1590].Fix(VELOCITY_Y); -NODES[1590].Fix(VELOCITY_Z); -NODES[1591].Fix(VELOCITY_X); -NODES[1591].Fix(VELOCITY_Y); -NODES[1591].Fix(VELOCITY_Z); -NODES[1592].Fix(VELOCITY_X); -NODES[1592].Fix(VELOCITY_Y); -NODES[1592].Fix(VELOCITY_Z); -NODES[1594].Fix(VELOCITY_X); -NODES[1594].Fix(VELOCITY_Y); -NODES[1594].Fix(VELOCITY_Z); -NODES[1595].Fix(VELOCITY_X); -NODES[1595].Fix(VELOCITY_Y); -NODES[1595].Fix(VELOCITY_Z); -NODES[1596].Fix(VELOCITY_X); -NODES[1596].Fix(VELOCITY_Y); -NODES[1596].Fix(VELOCITY_Z); -NODES[1597].Fix(VELOCITY_X); -NODES[1597].Fix(VELOCITY_Y); -NODES[1597].Fix(VELOCITY_Z); -NODES[1598].Fix(VELOCITY_X); -NODES[1598].Fix(VELOCITY_Y); -NODES[1598].Fix(VELOCITY_Z); -NODES[1599].Fix(VELOCITY_X); -NODES[1599].Fix(VELOCITY_Y); -NODES[1599].Fix(VELOCITY_Z); -NODES[1600].Fix(VELOCITY_X); -NODES[1600].Fix(VELOCITY_Y); -NODES[1600].Fix(VELOCITY_Z); -NODES[1601].Fix(VELOCITY_X); -NODES[1601].Fix(VELOCITY_Y); -NODES[1601].Fix(VELOCITY_Z); -NODES[1602].Fix(VELOCITY_X); -NODES[1602].Fix(VELOCITY_Y); -NODES[1602].Fix(VELOCITY_Z); -NODES[1603].Fix(VELOCITY_X); -NODES[1603].Fix(VELOCITY_Y); -NODES[1603].Fix(VELOCITY_Z); -NODES[1604].Fix(VELOCITY_X); -NODES[1604].Fix(VELOCITY_Y); -NODES[1604].Fix(VELOCITY_Z); -NODES[1605].Fix(VELOCITY_X); -NODES[1605].Fix(VELOCITY_Y); -NODES[1605].Fix(VELOCITY_Z); -NODES[1607].Fix(VELOCITY_X); -NODES[1607].Fix(VELOCITY_Y); -NODES[1607].Fix(VELOCITY_Z); -NODES[1608].Fix(VELOCITY_X); -NODES[1608].Fix(VELOCITY_Y); -NODES[1608].Fix(VELOCITY_Z); -NODES[1609].Fix(VELOCITY_X); -NODES[1609].Fix(VELOCITY_Y); -NODES[1609].Fix(VELOCITY_Z); -NODES[1611].Fix(VELOCITY_X); -NODES[1611].Fix(VELOCITY_Y); -NODES[1611].Fix(VELOCITY_Z); -NODES[1612].Fix(VELOCITY_X); -NODES[1612].Fix(VELOCITY_Y); -NODES[1612].Fix(VELOCITY_Z); -NODES[1614].Fix(VELOCITY_X); -NODES[1614].Fix(VELOCITY_Y); -NODES[1614].Fix(VELOCITY_Z); -NODES[1615].Fix(VELOCITY_X); -NODES[1615].Fix(VELOCITY_Y); -NODES[1615].Fix(VELOCITY_Z); -NODES[1617].Fix(VELOCITY_X); -NODES[1617].Fix(VELOCITY_Y); -NODES[1617].Fix(VELOCITY_Z); -NODES[1619].Fix(VELOCITY_X); -NODES[1619].Fix(VELOCITY_Y); -NODES[1619].Fix(VELOCITY_Z); -NODES[1620].Fix(VELOCITY_X); -NODES[1620].Fix(VELOCITY_Y); -NODES[1620].Fix(VELOCITY_Z); -NODES[1622].Fix(VELOCITY_X); -NODES[1622].Fix(VELOCITY_Y); -NODES[1622].Fix(VELOCITY_Z); -NODES[1623].Fix(VELOCITY_X); -NODES[1623].Fix(VELOCITY_Y); -NODES[1623].Fix(VELOCITY_Z); -NODES[1624].Fix(VELOCITY_X); -NODES[1624].Fix(VELOCITY_Y); -NODES[1624].Fix(VELOCITY_Z); -NODES[1626].Fix(VELOCITY_X); -NODES[1626].Fix(VELOCITY_Y); -NODES[1626].Fix(VELOCITY_Z); -NODES[1627].Fix(VELOCITY_X); -NODES[1627].Fix(VELOCITY_Y); -NODES[1627].Fix(VELOCITY_Z); -NODES[1628].Fix(VELOCITY_X); -NODES[1628].Fix(VELOCITY_Y); -NODES[1628].Fix(VELOCITY_Z); -NODES[1629].Fix(VELOCITY_X); -NODES[1629].Fix(VELOCITY_Y); -NODES[1629].Fix(VELOCITY_Z); -NODES[1630].Fix(VELOCITY_X); -NODES[1630].Fix(VELOCITY_Y); -NODES[1630].Fix(VELOCITY_Z); -NODES[1631].Fix(VELOCITY_X); -NODES[1631].Fix(VELOCITY_Y); -NODES[1631].Fix(VELOCITY_Z); -NODES[1632].Fix(VELOCITY_X); -NODES[1632].Fix(VELOCITY_Y); -NODES[1632].Fix(VELOCITY_Z); -NODES[1633].Fix(VELOCITY_X); -NODES[1633].Fix(VELOCITY_Y); -NODES[1633].Fix(VELOCITY_Z); -NODES[1634].Fix(VELOCITY_X); -NODES[1634].Fix(VELOCITY_Y); -NODES[1634].Fix(VELOCITY_Z); -NODES[1635].Fix(VELOCITY_X); -NODES[1635].Fix(VELOCITY_Y); -NODES[1635].Fix(VELOCITY_Z); -NODES[1636].Fix(VELOCITY_X); -NODES[1636].Fix(VELOCITY_Y); -NODES[1636].Fix(VELOCITY_Z); -NODES[1637].Fix(VELOCITY_X); -NODES[1637].Fix(VELOCITY_Y); -NODES[1637].Fix(VELOCITY_Z); -NODES[1638].Fix(VELOCITY_X); -NODES[1638].Fix(VELOCITY_Y); -NODES[1638].Fix(VELOCITY_Z); -NODES[1640].Fix(VELOCITY_X); -NODES[1640].Fix(VELOCITY_Y); -NODES[1640].Fix(VELOCITY_Z); -NODES[1642].Fix(VELOCITY_X); -NODES[1642].Fix(VELOCITY_Y); -NODES[1642].Fix(VELOCITY_Z); -NODES[1643].Fix(VELOCITY_X); -NODES[1643].Fix(VELOCITY_Y); -NODES[1643].Fix(VELOCITY_Z); -NODES[1645].Fix(VELOCITY_X); -NODES[1645].Fix(VELOCITY_Y); -NODES[1645].Fix(VELOCITY_Z); -NODES[1646].Fix(VELOCITY_X); -NODES[1646].Fix(VELOCITY_Y); -NODES[1646].Fix(VELOCITY_Z); -NODES[1647].Fix(VELOCITY_X); -NODES[1647].Fix(VELOCITY_Y); -NODES[1647].Fix(VELOCITY_Z); -NODES[1648].Fix(VELOCITY_X); -NODES[1648].Fix(VELOCITY_Y); -NODES[1648].Fix(VELOCITY_Z); -NODES[1649].Fix(VELOCITY_X); -NODES[1649].Fix(VELOCITY_Y); -NODES[1649].Fix(VELOCITY_Z); -NODES[1650].Fix(VELOCITY_X); -NODES[1650].Fix(VELOCITY_Y); -NODES[1650].Fix(VELOCITY_Z); -NODES[1651].Fix(VELOCITY_X); -NODES[1651].Fix(VELOCITY_Y); -NODES[1651].Fix(VELOCITY_Z); -NODES[1652].Fix(VELOCITY_X); -NODES[1652].Fix(VELOCITY_Y); -NODES[1652].Fix(VELOCITY_Z); -NODES[1653].Fix(VELOCITY_X); -NODES[1653].Fix(VELOCITY_Y); -NODES[1653].Fix(VELOCITY_Z); -NODES[1654].Fix(VELOCITY_X); -NODES[1654].Fix(VELOCITY_Y); -NODES[1654].Fix(VELOCITY_Z); -NODES[1655].Fix(VELOCITY_X); -NODES[1655].Fix(VELOCITY_Y); -NODES[1655].Fix(VELOCITY_Z); -NODES[1656].Fix(VELOCITY_X); -NODES[1656].Fix(VELOCITY_Y); -NODES[1656].Fix(VELOCITY_Z); -NODES[1657].Fix(VELOCITY_X); -NODES[1657].Fix(VELOCITY_Y); -NODES[1657].Fix(VELOCITY_Z); -NODES[1658].Fix(VELOCITY_X); -NODES[1658].Fix(VELOCITY_Y); -NODES[1658].Fix(VELOCITY_Z); -NODES[1661].Fix(VELOCITY_X); -NODES[1661].Fix(VELOCITY_Y); -NODES[1661].Fix(VELOCITY_Z); -NODES[1662].Fix(VELOCITY_X); -NODES[1662].Fix(VELOCITY_Y); -NODES[1662].Fix(VELOCITY_Z); -NODES[1663].Fix(VELOCITY_X); -NODES[1663].Fix(VELOCITY_Y); -NODES[1663].Fix(VELOCITY_Z); -NODES[1665].Fix(VELOCITY_X); -NODES[1665].Fix(VELOCITY_Y); -NODES[1665].Fix(VELOCITY_Z); -NODES[1666].Fix(VELOCITY_X); -NODES[1666].Fix(VELOCITY_Y); -NODES[1666].Fix(VELOCITY_Z); -NODES[1667].Fix(VELOCITY_X); -NODES[1667].Fix(VELOCITY_Y); -NODES[1667].Fix(VELOCITY_Z); -NODES[1668].Fix(VELOCITY_X); -NODES[1668].Fix(VELOCITY_Y); -NODES[1668].Fix(VELOCITY_Z); -NODES[1669].Fix(VELOCITY_X); -NODES[1669].Fix(VELOCITY_Y); -NODES[1669].Fix(VELOCITY_Z); -NODES[1670].Fix(VELOCITY_X); -NODES[1670].Fix(VELOCITY_Y); -NODES[1670].Fix(VELOCITY_Z); -NODES[1672].Fix(VELOCITY_X); -NODES[1672].Fix(VELOCITY_Y); -NODES[1672].Fix(VELOCITY_Z); -NODES[1673].Fix(VELOCITY_X); -NODES[1673].Fix(VELOCITY_Y); -NODES[1673].Fix(VELOCITY_Z); -NODES[1674].Fix(VELOCITY_X); -NODES[1674].Fix(VELOCITY_Y); -NODES[1674].Fix(VELOCITY_Z); -NODES[1675].Fix(VELOCITY_X); -NODES[1675].Fix(VELOCITY_Y); -NODES[1675].Fix(VELOCITY_Z); -NODES[1676].Fix(VELOCITY_X); -NODES[1676].Fix(VELOCITY_Y); -NODES[1676].Fix(VELOCITY_Z); -NODES[1678].Fix(VELOCITY_X); -NODES[1678].Fix(VELOCITY_Y); -NODES[1678].Fix(VELOCITY_Z); -NODES[1679].Fix(VELOCITY_X); -NODES[1679].Fix(VELOCITY_Y); -NODES[1679].Fix(VELOCITY_Z); -NODES[1682].Fix(VELOCITY_X); -NODES[1682].Fix(VELOCITY_Y); -NODES[1682].Fix(VELOCITY_Z); -NODES[1683].Fix(VELOCITY_X); -NODES[1683].Fix(VELOCITY_Y); -NODES[1683].Fix(VELOCITY_Z); -NODES[1684].Fix(VELOCITY_X); -NODES[1684].Fix(VELOCITY_Y); -NODES[1684].Fix(VELOCITY_Z); -NODES[1685].Fix(VELOCITY_X); -NODES[1685].Fix(VELOCITY_Y); -NODES[1685].Fix(VELOCITY_Z); -NODES[1686].Fix(VELOCITY_X); -NODES[1686].Fix(VELOCITY_Y); -NODES[1686].Fix(VELOCITY_Z); -NODES[1687].Fix(VELOCITY_X); -NODES[1687].Fix(VELOCITY_Y); -NODES[1687].Fix(VELOCITY_Z); -NODES[1688].Fix(VELOCITY_X); -NODES[1688].Fix(VELOCITY_Y); -NODES[1688].Fix(VELOCITY_Z); -NODES[1689].Fix(VELOCITY_X); -NODES[1689].Fix(VELOCITY_Y); -NODES[1689].Fix(VELOCITY_Z); -NODES[1690].Fix(VELOCITY_X); -NODES[1690].Fix(VELOCITY_Y); -NODES[1690].Fix(VELOCITY_Z); -NODES[1691].Fix(VELOCITY_X); -NODES[1691].Fix(VELOCITY_Y); -NODES[1691].Fix(VELOCITY_Z); -NODES[1692].Fix(VELOCITY_X); -NODES[1692].Fix(VELOCITY_Y); -NODES[1692].Fix(VELOCITY_Z); -NODES[1694].Fix(VELOCITY_X); -NODES[1694].Fix(VELOCITY_Y); -NODES[1694].Fix(VELOCITY_Z); -NODES[1695].Fix(VELOCITY_X); -NODES[1695].Fix(VELOCITY_Y); -NODES[1695].Fix(VELOCITY_Z); -NODES[1696].Fix(VELOCITY_X); -NODES[1696].Fix(VELOCITY_Y); -NODES[1696].Fix(VELOCITY_Z); -NODES[1699].Fix(VELOCITY_X); -NODES[1699].Fix(VELOCITY_Y); -NODES[1699].Fix(VELOCITY_Z); -NODES[1700].Fix(VELOCITY_X); -NODES[1700].Fix(VELOCITY_Y); -NODES[1700].Fix(VELOCITY_Z); -NODES[1701].Fix(VELOCITY_X); -NODES[1701].Fix(VELOCITY_Y); -NODES[1701].Fix(VELOCITY_Z); -NODES[1703].Fix(VELOCITY_X); -NODES[1703].Fix(VELOCITY_Y); -NODES[1703].Fix(VELOCITY_Z); -NODES[1704].Fix(VELOCITY_X); -NODES[1704].Fix(VELOCITY_Y); -NODES[1704].Fix(VELOCITY_Z); -NODES[1707].Fix(VELOCITY_X); -NODES[1707].Fix(VELOCITY_Y); -NODES[1707].Fix(VELOCITY_Z); -NODES[1708].Fix(VELOCITY_X); -NODES[1708].Fix(VELOCITY_Y); -NODES[1708].Fix(VELOCITY_Z); -NODES[1709].Fix(VELOCITY_X); -NODES[1709].Fix(VELOCITY_Y); -NODES[1709].Fix(VELOCITY_Z); -NODES[1710].Fix(VELOCITY_X); -NODES[1710].Fix(VELOCITY_Y); -NODES[1710].Fix(VELOCITY_Z); -NODES[1714].Fix(VELOCITY_X); -NODES[1714].Fix(VELOCITY_Y); -NODES[1714].Fix(VELOCITY_Z); -NODES[1716].Fix(VELOCITY_X); -NODES[1716].Fix(VELOCITY_Y); -NODES[1716].Fix(VELOCITY_Z); -NODES[1718].Fix(VELOCITY_X); -NODES[1718].Fix(VELOCITY_Y); -NODES[1718].Fix(VELOCITY_Z); -NODES[1719].Fix(VELOCITY_X); -NODES[1719].Fix(VELOCITY_Y); -NODES[1719].Fix(VELOCITY_Z); -NODES[1720].Fix(VELOCITY_X); -NODES[1720].Fix(VELOCITY_Y); -NODES[1720].Fix(VELOCITY_Z); -NODES[1724].Fix(VELOCITY_X); -NODES[1724].Fix(VELOCITY_Y); -NODES[1724].Fix(VELOCITY_Z); -NODES[1725].Fix(VELOCITY_X); -NODES[1725].Fix(VELOCITY_Y); -NODES[1725].Fix(VELOCITY_Z); -NODES[1726].Fix(VELOCITY_X); -NODES[1726].Fix(VELOCITY_Y); -NODES[1726].Fix(VELOCITY_Z); -NODES[1730].Fix(VELOCITY_X); -NODES[1730].Fix(VELOCITY_Y); -NODES[1730].Fix(VELOCITY_Z); -NODES[1731].Fix(VELOCITY_X); -NODES[1731].Fix(VELOCITY_Y); -NODES[1731].Fix(VELOCITY_Z); -NODES[1732].Fix(VELOCITY_X); -NODES[1732].Fix(VELOCITY_Y); -NODES[1732].Fix(VELOCITY_Z); -NODES[1733].Fix(VELOCITY_X); -NODES[1733].Fix(VELOCITY_Y); -NODES[1733].Fix(VELOCITY_Z); -NODES[1734].Fix(VELOCITY_X); -NODES[1734].Fix(VELOCITY_Y); -NODES[1734].Fix(VELOCITY_Z); -NODES[1735].Fix(VELOCITY_X); -NODES[1735].Fix(VELOCITY_Y); -NODES[1735].Fix(VELOCITY_Z); -NODES[1736].Fix(VELOCITY_X); -NODES[1736].Fix(VELOCITY_Y); -NODES[1736].Fix(VELOCITY_Z); -NODES[1737].Fix(VELOCITY_X); -NODES[1737].Fix(VELOCITY_Y); -NODES[1737].Fix(VELOCITY_Z); -NODES[1738].Fix(VELOCITY_X); -NODES[1738].Fix(VELOCITY_Y); -NODES[1738].Fix(VELOCITY_Z); -NODES[1741].Fix(VELOCITY_X); -NODES[1741].Fix(VELOCITY_Y); -NODES[1741].Fix(VELOCITY_Z); -NODES[1742].Fix(VELOCITY_X); -NODES[1742].Fix(VELOCITY_Y); -NODES[1742].Fix(VELOCITY_Z); -NODES[1743].Fix(VELOCITY_X); -NODES[1743].Fix(VELOCITY_Y); -NODES[1743].Fix(VELOCITY_Z); -NODES[1745].Fix(VELOCITY_X); -NODES[1745].Fix(VELOCITY_Y); -NODES[1745].Fix(VELOCITY_Z); -NODES[1747].Fix(VELOCITY_X); -NODES[1747].Fix(VELOCITY_Y); -NODES[1747].Fix(VELOCITY_Z); -NODES[1748].Fix(VELOCITY_X); -NODES[1748].Fix(VELOCITY_Y); -NODES[1748].Fix(VELOCITY_Z); -NODES[1749].Fix(VELOCITY_X); -NODES[1749].Fix(VELOCITY_Y); -NODES[1749].Fix(VELOCITY_Z); -NODES[1750].Fix(VELOCITY_X); -NODES[1750].Fix(VELOCITY_Y); -NODES[1750].Fix(VELOCITY_Z); -NODES[1753].Fix(VELOCITY_X); -NODES[1753].Fix(VELOCITY_Y); -NODES[1753].Fix(VELOCITY_Z); -NODES[1754].Fix(VELOCITY_X); -NODES[1754].Fix(VELOCITY_Y); -NODES[1754].Fix(VELOCITY_Z); -NODES[1755].Fix(VELOCITY_X); -NODES[1755].Fix(VELOCITY_Y); -NODES[1755].Fix(VELOCITY_Z); -NODES[1757].Fix(VELOCITY_X); -NODES[1757].Fix(VELOCITY_Y); -NODES[1757].Fix(VELOCITY_Z); -NODES[1758].Fix(VELOCITY_X); -NODES[1758].Fix(VELOCITY_Y); -NODES[1758].Fix(VELOCITY_Z); -NODES[1760].Fix(VELOCITY_X); -NODES[1760].Fix(VELOCITY_Y); -NODES[1760].Fix(VELOCITY_Z); -NODES[1761].Fix(VELOCITY_X); -NODES[1761].Fix(VELOCITY_Y); -NODES[1761].Fix(VELOCITY_Z); -NODES[1762].Fix(VELOCITY_X); -NODES[1762].Fix(VELOCITY_Y); -NODES[1762].Fix(VELOCITY_Z); -NODES[1763].Fix(VELOCITY_X); -NODES[1763].Fix(VELOCITY_Y); -NODES[1763].Fix(VELOCITY_Z); -NODES[1764].Fix(VELOCITY_X); -NODES[1764].Fix(VELOCITY_Y); -NODES[1764].Fix(VELOCITY_Z); -NODES[1765].Fix(VELOCITY_X); -NODES[1765].Fix(VELOCITY_Y); -NODES[1765].Fix(VELOCITY_Z); -NODES[1766].Fix(VELOCITY_X); -NODES[1766].Fix(VELOCITY_Y); -NODES[1766].Fix(VELOCITY_Z); -NODES[1768].Fix(VELOCITY_X); -NODES[1768].Fix(VELOCITY_Y); -NODES[1768].Fix(VELOCITY_Z); -NODES[1769].Fix(VELOCITY_X); -NODES[1769].Fix(VELOCITY_Y); -NODES[1769].Fix(VELOCITY_Z); -NODES[1770].Fix(VELOCITY_X); -NODES[1770].Fix(VELOCITY_Y); -NODES[1770].Fix(VELOCITY_Z); -NODES[1771].Fix(VELOCITY_X); -NODES[1771].Fix(VELOCITY_Y); -NODES[1771].Fix(VELOCITY_Z); -NODES[1772].Fix(VELOCITY_X); -NODES[1772].Fix(VELOCITY_Y); -NODES[1772].Fix(VELOCITY_Z); -NODES[1773].Fix(VELOCITY_X); -NODES[1773].Fix(VELOCITY_Y); -NODES[1773].Fix(VELOCITY_Z); -NODES[1774].Fix(VELOCITY_X); -NODES[1774].Fix(VELOCITY_Y); -NODES[1774].Fix(VELOCITY_Z); -NODES[1775].Fix(VELOCITY_X); -NODES[1775].Fix(VELOCITY_Y); -NODES[1775].Fix(VELOCITY_Z); -NODES[1776].Fix(VELOCITY_X); -NODES[1776].Fix(VELOCITY_Y); -NODES[1776].Fix(VELOCITY_Z); -NODES[1777].Fix(VELOCITY_X); -NODES[1777].Fix(VELOCITY_Y); -NODES[1777].Fix(VELOCITY_Z); -NODES[1778].Fix(VELOCITY_X); -NODES[1778].Fix(VELOCITY_Y); -NODES[1778].Fix(VELOCITY_Z); -NODES[1779].Fix(VELOCITY_X); -NODES[1779].Fix(VELOCITY_Y); -NODES[1779].Fix(VELOCITY_Z); -NODES[1780].Fix(VELOCITY_X); -NODES[1780].Fix(VELOCITY_Y); -NODES[1780].Fix(VELOCITY_Z); -NODES[1781].Fix(VELOCITY_X); -NODES[1781].Fix(VELOCITY_Y); -NODES[1781].Fix(VELOCITY_Z); -NODES[1784].Fix(VELOCITY_X); -NODES[1784].Fix(VELOCITY_Y); -NODES[1784].Fix(VELOCITY_Z); -NODES[1787].Fix(VELOCITY_X); -NODES[1787].Fix(VELOCITY_Y); -NODES[1787].Fix(VELOCITY_Z); -NODES[1788].Fix(VELOCITY_X); -NODES[1788].Fix(VELOCITY_Y); -NODES[1788].Fix(VELOCITY_Z); -NODES[1790].Fix(VELOCITY_X); -NODES[1790].Fix(VELOCITY_Y); -NODES[1790].Fix(VELOCITY_Z); -NODES[1792].Fix(VELOCITY_X); -NODES[1792].Fix(VELOCITY_Y); -NODES[1792].Fix(VELOCITY_Z); -NODES[1793].Fix(VELOCITY_X); -NODES[1793].Fix(VELOCITY_Y); -NODES[1793].Fix(VELOCITY_Z); -NODES[1794].Fix(VELOCITY_X); -NODES[1794].Fix(VELOCITY_Y); -NODES[1794].Fix(VELOCITY_Z); -NODES[1796].Fix(VELOCITY_X); -NODES[1796].Fix(VELOCITY_Y); -NODES[1796].Fix(VELOCITY_Z); -NODES[1797].Fix(VELOCITY_X); -NODES[1797].Fix(VELOCITY_Y); -NODES[1797].Fix(VELOCITY_Z); -NODES[1798].Fix(VELOCITY_X); -NODES[1798].Fix(VELOCITY_Y); -NODES[1798].Fix(VELOCITY_Z); -NODES[1799].Fix(VELOCITY_X); -NODES[1799].Fix(VELOCITY_Y); -NODES[1799].Fix(VELOCITY_Z); -NODES[1800].Fix(VELOCITY_X); -NODES[1800].Fix(VELOCITY_Y); -NODES[1800].Fix(VELOCITY_Z); -NODES[1805].Fix(VELOCITY_X); -NODES[1805].Fix(VELOCITY_Y); -NODES[1805].Fix(VELOCITY_Z); -NODES[1806].Fix(VELOCITY_X); -NODES[1806].Fix(VELOCITY_Y); -NODES[1806].Fix(VELOCITY_Z); -NODES[1810].Fix(VELOCITY_X); -NODES[1810].Fix(VELOCITY_Y); -NODES[1810].Fix(VELOCITY_Z); -NODES[1813].Fix(VELOCITY_X); -NODES[1813].Fix(VELOCITY_Y); -NODES[1813].Fix(VELOCITY_Z); -NODES[1815].Fix(VELOCITY_X); -NODES[1815].Fix(VELOCITY_Y); -NODES[1815].Fix(VELOCITY_Z); -NODES[1817].Fix(VELOCITY_X); -NODES[1817].Fix(VELOCITY_Y); -NODES[1817].Fix(VELOCITY_Z); -NODES[1819].Fix(VELOCITY_X); -NODES[1819].Fix(VELOCITY_Y); -NODES[1819].Fix(VELOCITY_Z); -NODES[1820].Fix(VELOCITY_X); -NODES[1820].Fix(VELOCITY_Y); -NODES[1820].Fix(VELOCITY_Z); -NODES[1822].Fix(VELOCITY_X); -NODES[1822].Fix(VELOCITY_Y); -NODES[1822].Fix(VELOCITY_Z); -NODES[1824].Fix(VELOCITY_X); -NODES[1824].Fix(VELOCITY_Y); -NODES[1824].Fix(VELOCITY_Z); -NODES[1825].Fix(VELOCITY_X); -NODES[1825].Fix(VELOCITY_Y); -NODES[1825].Fix(VELOCITY_Z); -NODES[1826].Fix(VELOCITY_X); -NODES[1826].Fix(VELOCITY_Y); -NODES[1826].Fix(VELOCITY_Z); -NODES[1827].Fix(VELOCITY_X); -NODES[1827].Fix(VELOCITY_Y); -NODES[1827].Fix(VELOCITY_Z); -NODES[1830].Fix(VELOCITY_X); -NODES[1830].Fix(VELOCITY_Y); -NODES[1830].Fix(VELOCITY_Z); -NODES[1834].Fix(VELOCITY_X); -NODES[1834].Fix(VELOCITY_Y); -NODES[1834].Fix(VELOCITY_Z); -NODES[1835].Fix(VELOCITY_X); -NODES[1835].Fix(VELOCITY_Y); -NODES[1835].Fix(VELOCITY_Z); -NODES[1837].Fix(VELOCITY_X); -NODES[1837].Fix(VELOCITY_Y); -NODES[1837].Fix(VELOCITY_Z); -NODES[1838].Fix(VELOCITY_X); -NODES[1838].Fix(VELOCITY_Y); -NODES[1838].Fix(VELOCITY_Z); -NODES[1841].Fix(VELOCITY_X); -NODES[1841].Fix(VELOCITY_Y); -NODES[1841].Fix(VELOCITY_Z); -NODES[1842].Fix(VELOCITY_X); -NODES[1842].Fix(VELOCITY_Y); -NODES[1842].Fix(VELOCITY_Z); -NODES[1843].Fix(VELOCITY_X); -NODES[1843].Fix(VELOCITY_Y); -NODES[1843].Fix(VELOCITY_Z); -NODES[1844].Fix(VELOCITY_X); -NODES[1844].Fix(VELOCITY_Y); -NODES[1844].Fix(VELOCITY_Z); -NODES[1845].Fix(VELOCITY_X); -NODES[1845].Fix(VELOCITY_Y); -NODES[1845].Fix(VELOCITY_Z); -NODES[1847].Fix(VELOCITY_X); -NODES[1847].Fix(VELOCITY_Y); -NODES[1847].Fix(VELOCITY_Z); -NODES[1850].Fix(VELOCITY_X); -NODES[1850].Fix(VELOCITY_Y); -NODES[1850].Fix(VELOCITY_Z); -NODES[1851].Fix(VELOCITY_X); -NODES[1851].Fix(VELOCITY_Y); -NODES[1851].Fix(VELOCITY_Z); -NODES[1852].Fix(VELOCITY_X); -NODES[1852].Fix(VELOCITY_Y); -NODES[1852].Fix(VELOCITY_Z); -NODES[1853].Fix(VELOCITY_X); -NODES[1853].Fix(VELOCITY_Y); -NODES[1853].Fix(VELOCITY_Z); -NODES[1855].Fix(VELOCITY_X); -NODES[1855].Fix(VELOCITY_Y); -NODES[1855].Fix(VELOCITY_Z); -NODES[1857].Fix(VELOCITY_X); -NODES[1857].Fix(VELOCITY_Y); -NODES[1857].Fix(VELOCITY_Z); -NODES[1858].Fix(VELOCITY_X); -NODES[1858].Fix(VELOCITY_Y); -NODES[1858].Fix(VELOCITY_Z); -NODES[1859].Fix(VELOCITY_X); -NODES[1859].Fix(VELOCITY_Y); -NODES[1859].Fix(VELOCITY_Z); -NODES[1860].Fix(VELOCITY_X); -NODES[1860].Fix(VELOCITY_Y); -NODES[1860].Fix(VELOCITY_Z); -NODES[1863].Fix(VELOCITY_X); -NODES[1863].Fix(VELOCITY_Y); -NODES[1863].Fix(VELOCITY_Z); -NODES[1864].Fix(VELOCITY_X); -NODES[1864].Fix(VELOCITY_Y); -NODES[1864].Fix(VELOCITY_Z); -NODES[1865].Fix(VELOCITY_X); -NODES[1865].Fix(VELOCITY_Y); -NODES[1865].Fix(VELOCITY_Z); -NODES[1866].Fix(VELOCITY_X); -NODES[1866].Fix(VELOCITY_Y); -NODES[1866].Fix(VELOCITY_Z); -NODES[1867].Fix(VELOCITY_X); -NODES[1867].Fix(VELOCITY_Y); -NODES[1867].Fix(VELOCITY_Z); -NODES[1871].Fix(VELOCITY_X); -NODES[1871].Fix(VELOCITY_Y); -NODES[1871].Fix(VELOCITY_Z); -NODES[1877].Fix(VELOCITY_X); -NODES[1877].Fix(VELOCITY_Y); -NODES[1877].Fix(VELOCITY_Z); -NODES[1882].Fix(VELOCITY_X); -NODES[1882].Fix(VELOCITY_Y); -NODES[1882].Fix(VELOCITY_Z); -NODES[1883].Fix(VELOCITY_X); -NODES[1883].Fix(VELOCITY_Y); -NODES[1883].Fix(VELOCITY_Z); -NODES[1884].Fix(VELOCITY_X); -NODES[1884].Fix(VELOCITY_Y); -NODES[1884].Fix(VELOCITY_Z); -NODES[1886].Fix(VELOCITY_X); -NODES[1886].Fix(VELOCITY_Y); -NODES[1886].Fix(VELOCITY_Z); -NODES[1890].Fix(VELOCITY_X); -NODES[1890].Fix(VELOCITY_Y); -NODES[1890].Fix(VELOCITY_Z); -NODES[1891].Fix(VELOCITY_X); -NODES[1891].Fix(VELOCITY_Y); -NODES[1891].Fix(VELOCITY_Z); -NODES[1892].Fix(VELOCITY_X); -NODES[1892].Fix(VELOCITY_Y); -NODES[1892].Fix(VELOCITY_Z); -NODES[1894].Fix(VELOCITY_X); -NODES[1894].Fix(VELOCITY_Y); -NODES[1894].Fix(VELOCITY_Z); -NODES[1895].Fix(VELOCITY_X); -NODES[1895].Fix(VELOCITY_Y); -NODES[1895].Fix(VELOCITY_Z); -NODES[1896].Fix(VELOCITY_X); -NODES[1896].Fix(VELOCITY_Y); -NODES[1896].Fix(VELOCITY_Z); -NODES[1898].Fix(VELOCITY_X); -NODES[1898].Fix(VELOCITY_Y); -NODES[1898].Fix(VELOCITY_Z); -NODES[1899].Fix(VELOCITY_X); -NODES[1899].Fix(VELOCITY_Y); -NODES[1899].Fix(VELOCITY_Z); -NODES[1900].Fix(VELOCITY_X); -NODES[1900].Fix(VELOCITY_Y); -NODES[1900].Fix(VELOCITY_Z); -NODES[1901].Fix(VELOCITY_X); -NODES[1901].Fix(VELOCITY_Y); -NODES[1901].Fix(VELOCITY_Z); -NODES[1902].Fix(VELOCITY_X); -NODES[1902].Fix(VELOCITY_Y); -NODES[1902].Fix(VELOCITY_Z); -NODES[1903].Fix(VELOCITY_X); -NODES[1903].Fix(VELOCITY_Y); -NODES[1903].Fix(VELOCITY_Z); -NODES[1904].Fix(VELOCITY_X); -NODES[1904].Fix(VELOCITY_Y); -NODES[1904].Fix(VELOCITY_Z); -NODES[1905].Fix(VELOCITY_X); -NODES[1905].Fix(VELOCITY_Y); -NODES[1905].Fix(VELOCITY_Z); -NODES[1908].Fix(VELOCITY_X); -NODES[1908].Fix(VELOCITY_Y); -NODES[1908].Fix(VELOCITY_Z); -NODES[1909].Fix(VELOCITY_X); -NODES[1909].Fix(VELOCITY_Y); -NODES[1909].Fix(VELOCITY_Z); -NODES[1912].Fix(VELOCITY_X); -NODES[1912].Fix(VELOCITY_Y); -NODES[1912].Fix(VELOCITY_Z); -NODES[1914].Fix(VELOCITY_X); -NODES[1914].Fix(VELOCITY_Y); -NODES[1914].Fix(VELOCITY_Z); -NODES[1918].Fix(VELOCITY_X); -NODES[1918].Fix(VELOCITY_Y); -NODES[1918].Fix(VELOCITY_Z); -NODES[1920].Fix(VELOCITY_X); -NODES[1920].Fix(VELOCITY_Y); -NODES[1920].Fix(VELOCITY_Z); -NODES[1921].Fix(VELOCITY_X); -NODES[1921].Fix(VELOCITY_Y); -NODES[1921].Fix(VELOCITY_Z); -NODES[1923].Fix(VELOCITY_X); -NODES[1923].Fix(VELOCITY_Y); -NODES[1923].Fix(VELOCITY_Z); -NODES[1925].Fix(VELOCITY_X); -NODES[1925].Fix(VELOCITY_Y); -NODES[1925].Fix(VELOCITY_Z); -NODES[1926].Fix(VELOCITY_X); -NODES[1926].Fix(VELOCITY_Y); -NODES[1926].Fix(VELOCITY_Z); -NODES[1927].Fix(VELOCITY_X); -NODES[1927].Fix(VELOCITY_Y); -NODES[1927].Fix(VELOCITY_Z); -NODES[1929].Fix(VELOCITY_X); -NODES[1929].Fix(VELOCITY_Y); -NODES[1929].Fix(VELOCITY_Z); -NODES[1930].Fix(VELOCITY_X); -NODES[1930].Fix(VELOCITY_Y); -NODES[1930].Fix(VELOCITY_Z); -NODES[1934].Fix(VELOCITY_X); -NODES[1934].Fix(VELOCITY_Y); -NODES[1934].Fix(VELOCITY_Z); -NODES[1935].Fix(VELOCITY_X); -NODES[1935].Fix(VELOCITY_Y); -NODES[1935].Fix(VELOCITY_Z); -NODES[1936].Fix(VELOCITY_X); -NODES[1936].Fix(VELOCITY_Y); -NODES[1936].Fix(VELOCITY_Z); -NODES[1937].Fix(VELOCITY_X); -NODES[1937].Fix(VELOCITY_Y); -NODES[1937].Fix(VELOCITY_Z); -NODES[1940].Fix(VELOCITY_X); -NODES[1940].Fix(VELOCITY_Y); -NODES[1940].Fix(VELOCITY_Z); -NODES[1943].Fix(VELOCITY_X); -NODES[1943].Fix(VELOCITY_Y); -NODES[1943].Fix(VELOCITY_Z); -NODES[1944].Fix(VELOCITY_X); -NODES[1944].Fix(VELOCITY_Y); -NODES[1944].Fix(VELOCITY_Z); -NODES[1945].Fix(VELOCITY_X); -NODES[1945].Fix(VELOCITY_Y); -NODES[1945].Fix(VELOCITY_Z); -NODES[1946].Fix(VELOCITY_X); -NODES[1946].Fix(VELOCITY_Y); -NODES[1946].Fix(VELOCITY_Z); -NODES[1947].Fix(VELOCITY_X); -NODES[1947].Fix(VELOCITY_Y); -NODES[1947].Fix(VELOCITY_Z); -NODES[1950].Fix(VELOCITY_X); -NODES[1950].Fix(VELOCITY_Y); -NODES[1950].Fix(VELOCITY_Z); -NODES[1951].Fix(VELOCITY_X); -NODES[1951].Fix(VELOCITY_Y); -NODES[1951].Fix(VELOCITY_Z); -NODES[1953].Fix(VELOCITY_X); -NODES[1953].Fix(VELOCITY_Y); -NODES[1953].Fix(VELOCITY_Z); -NODES[1954].Fix(VELOCITY_X); -NODES[1954].Fix(VELOCITY_Y); -NODES[1954].Fix(VELOCITY_Z); -NODES[1957].Fix(VELOCITY_X); -NODES[1957].Fix(VELOCITY_Y); -NODES[1957].Fix(VELOCITY_Z); -NODES[1962].Fix(VELOCITY_X); -NODES[1962].Fix(VELOCITY_Y); -NODES[1962].Fix(VELOCITY_Z); -NODES[1963].Fix(VELOCITY_X); -NODES[1963].Fix(VELOCITY_Y); -NODES[1963].Fix(VELOCITY_Z); -NODES[1965].Fix(VELOCITY_X); -NODES[1965].Fix(VELOCITY_Y); -NODES[1965].Fix(VELOCITY_Z); -NODES[1968].Fix(VELOCITY_X); -NODES[1968].Fix(VELOCITY_Y); -NODES[1968].Fix(VELOCITY_Z); -NODES[1970].Fix(VELOCITY_X); -NODES[1970].Fix(VELOCITY_Y); -NODES[1970].Fix(VELOCITY_Z); -NODES[1971].Fix(VELOCITY_X); -NODES[1971].Fix(VELOCITY_Y); -NODES[1971].Fix(VELOCITY_Z); -NODES[1974].Fix(VELOCITY_X); -NODES[1974].Fix(VELOCITY_Y); -NODES[1974].Fix(VELOCITY_Z); -NODES[1979].Fix(VELOCITY_X); -NODES[1979].Fix(VELOCITY_Y); -NODES[1979].Fix(VELOCITY_Z); -NODES[1980].Fix(VELOCITY_X); -NODES[1980].Fix(VELOCITY_Y); -NODES[1980].Fix(VELOCITY_Z); -NODES[1981].Fix(VELOCITY_X); -NODES[1981].Fix(VELOCITY_Y); -NODES[1981].Fix(VELOCITY_Z); -NODES[1982].Fix(VELOCITY_X); -NODES[1982].Fix(VELOCITY_Y); -NODES[1982].Fix(VELOCITY_Z); -NODES[1983].Fix(VELOCITY_X); -NODES[1983].Fix(VELOCITY_Y); -NODES[1983].Fix(VELOCITY_Z); -NODES[1984].Fix(VELOCITY_X); -NODES[1984].Fix(VELOCITY_Y); -NODES[1984].Fix(VELOCITY_Z); -NODES[1986].Fix(VELOCITY_X); -NODES[1986].Fix(VELOCITY_Y); -NODES[1986].Fix(VELOCITY_Z); -NODES[1988].Fix(VELOCITY_X); -NODES[1988].Fix(VELOCITY_Y); -NODES[1988].Fix(VELOCITY_Z); -NODES[1990].Fix(VELOCITY_X); -NODES[1990].Fix(VELOCITY_Y); -NODES[1990].Fix(VELOCITY_Z); -NODES[1991].Fix(VELOCITY_X); -NODES[1991].Fix(VELOCITY_Y); -NODES[1991].Fix(VELOCITY_Z); -NODES[1993].Fix(VELOCITY_X); -NODES[1993].Fix(VELOCITY_Y); -NODES[1993].Fix(VELOCITY_Z); -NODES[1994].Fix(VELOCITY_X); -NODES[1994].Fix(VELOCITY_Y); -NODES[1994].Fix(VELOCITY_Z); -NODES[1996].Fix(VELOCITY_X); -NODES[1996].Fix(VELOCITY_Y); -NODES[1996].Fix(VELOCITY_Z); -NODES[1998].Fix(VELOCITY_X); -NODES[1998].Fix(VELOCITY_Y); -NODES[1998].Fix(VELOCITY_Z); -NODES[2000].Fix(VELOCITY_X); -NODES[2000].Fix(VELOCITY_Y); -NODES[2000].Fix(VELOCITY_Z); -NODES[2003].Fix(VELOCITY_X); -NODES[2003].Fix(VELOCITY_Y); -NODES[2003].Fix(VELOCITY_Z); -NODES[2004].Fix(VELOCITY_X); -NODES[2004].Fix(VELOCITY_Y); -NODES[2004].Fix(VELOCITY_Z); -NODES[2005].Fix(VELOCITY_X); -NODES[2005].Fix(VELOCITY_Y); -NODES[2005].Fix(VELOCITY_Z); -NODES[2011].Fix(VELOCITY_X); -NODES[2011].Fix(VELOCITY_Y); -NODES[2011].Fix(VELOCITY_Z); -NODES[2014].Fix(VELOCITY_X); -NODES[2014].Fix(VELOCITY_Y); -NODES[2014].Fix(VELOCITY_Z); -NODES[2015].Fix(VELOCITY_X); -NODES[2015].Fix(VELOCITY_Y); -NODES[2015].Fix(VELOCITY_Z); -NODES[2016].Fix(VELOCITY_X); -NODES[2016].Fix(VELOCITY_Y); -NODES[2016].Fix(VELOCITY_Z); -NODES[2017].Fix(VELOCITY_X); -NODES[2017].Fix(VELOCITY_Y); -NODES[2017].Fix(VELOCITY_Z); -NODES[2020].Fix(VELOCITY_X); -NODES[2020].Fix(VELOCITY_Y); -NODES[2020].Fix(VELOCITY_Z); -NODES[2023].Fix(VELOCITY_X); -NODES[2023].Fix(VELOCITY_Y); -NODES[2023].Fix(VELOCITY_Z); -NODES[2024].Fix(VELOCITY_X); -NODES[2024].Fix(VELOCITY_Y); -NODES[2024].Fix(VELOCITY_Z); -NODES[2029].Fix(VELOCITY_X); -NODES[2029].Fix(VELOCITY_Y); -NODES[2029].Fix(VELOCITY_Z); -NODES[2031].Fix(VELOCITY_X); -NODES[2031].Fix(VELOCITY_Y); -NODES[2031].Fix(VELOCITY_Z); -NODES[2035].Fix(VELOCITY_X); -NODES[2035].Fix(VELOCITY_Y); -NODES[2035].Fix(VELOCITY_Z); -NODES[2036].Fix(VELOCITY_X); -NODES[2036].Fix(VELOCITY_Y); -NODES[2036].Fix(VELOCITY_Z); -NODES[2039].Fix(VELOCITY_X); -NODES[2039].Fix(VELOCITY_Y); -NODES[2039].Fix(VELOCITY_Z); -NODES[2040].Fix(VELOCITY_X); -NODES[2040].Fix(VELOCITY_Y); -NODES[2040].Fix(VELOCITY_Z); -NODES[2042].Fix(VELOCITY_X); -NODES[2042].Fix(VELOCITY_Y); -NODES[2042].Fix(VELOCITY_Z); -NODES[2044].Fix(VELOCITY_X); -NODES[2044].Fix(VELOCITY_Y); -NODES[2044].Fix(VELOCITY_Z); -NODES[2048].Fix(VELOCITY_X); -NODES[2048].Fix(VELOCITY_Y); -NODES[2048].Fix(VELOCITY_Z); -NODES[2049].Fix(VELOCITY_X); -NODES[2049].Fix(VELOCITY_Y); -NODES[2049].Fix(VELOCITY_Z); -NODES[2050].Fix(VELOCITY_X); -NODES[2050].Fix(VELOCITY_Y); -NODES[2050].Fix(VELOCITY_Z); -NODES[2053].Fix(VELOCITY_X); -NODES[2053].Fix(VELOCITY_Y); -NODES[2053].Fix(VELOCITY_Z); -NODES[2055].Fix(VELOCITY_X); -NODES[2055].Fix(VELOCITY_Y); -NODES[2055].Fix(VELOCITY_Z); -NODES[2059].Fix(VELOCITY_X); -NODES[2059].Fix(VELOCITY_Y); -NODES[2059].Fix(VELOCITY_Z); -NODES[2063].Fix(VELOCITY_X); -NODES[2063].Fix(VELOCITY_Y); -NODES[2063].Fix(VELOCITY_Z); -NODES[2067].Fix(VELOCITY_X); -NODES[2067].Fix(VELOCITY_Y); -NODES[2067].Fix(VELOCITY_Z); -NODES[2068].Fix(VELOCITY_X); -NODES[2068].Fix(VELOCITY_Y); -NODES[2068].Fix(VELOCITY_Z); -NODES[2069].Fix(VELOCITY_X); -NODES[2069].Fix(VELOCITY_Y); -NODES[2069].Fix(VELOCITY_Z); -NODES[2070].Fix(VELOCITY_X); -NODES[2070].Fix(VELOCITY_Y); -NODES[2070].Fix(VELOCITY_Z); -NODES[2073].Fix(VELOCITY_X); -NODES[2073].Fix(VELOCITY_Y); -NODES[2073].Fix(VELOCITY_Z); -NODES[2077].Fix(VELOCITY_X); -NODES[2077].Fix(VELOCITY_Y); -NODES[2077].Fix(VELOCITY_Z); -NODES[2082].Fix(VELOCITY_X); -NODES[2082].Fix(VELOCITY_Y); -NODES[2082].Fix(VELOCITY_Z); -NODES[2084].Fix(VELOCITY_X); -NODES[2084].Fix(VELOCITY_Y); -NODES[2084].Fix(VELOCITY_Z); -NODES[2085].Fix(VELOCITY_X); -NODES[2085].Fix(VELOCITY_Y); -NODES[2085].Fix(VELOCITY_Z); -NODES[2088].Fix(VELOCITY_X); -NODES[2088].Fix(VELOCITY_Y); -NODES[2088].Fix(VELOCITY_Z); -NODES[2089].Fix(VELOCITY_X); -NODES[2089].Fix(VELOCITY_Y); -NODES[2089].Fix(VELOCITY_Z); -NODES[2090].Fix(VELOCITY_X); -NODES[2090].Fix(VELOCITY_Y); -NODES[2090].Fix(VELOCITY_Z); -NODES[2091].Fix(VELOCITY_X); -NODES[2091].Fix(VELOCITY_Y); -NODES[2091].Fix(VELOCITY_Z); -NODES[2093].Fix(VELOCITY_X); -NODES[2093].Fix(VELOCITY_Y); -NODES[2093].Fix(VELOCITY_Z); -NODES[2095].Fix(VELOCITY_X); -NODES[2095].Fix(VELOCITY_Y); -NODES[2095].Fix(VELOCITY_Z); -NODES[2097].Fix(VELOCITY_X); -NODES[2097].Fix(VELOCITY_Y); -NODES[2097].Fix(VELOCITY_Z); -NODES[2100].Fix(VELOCITY_X); -NODES[2100].Fix(VELOCITY_Y); -NODES[2100].Fix(VELOCITY_Z); -NODES[2101].Fix(VELOCITY_X); -NODES[2101].Fix(VELOCITY_Y); -NODES[2101].Fix(VELOCITY_Z); -NODES[2102].Fix(VELOCITY_X); -NODES[2102].Fix(VELOCITY_Y); -NODES[2102].Fix(VELOCITY_Z); -NODES[2103].Fix(VELOCITY_X); -NODES[2103].Fix(VELOCITY_Y); -NODES[2103].Fix(VELOCITY_Z); -NODES[2104].Fix(VELOCITY_X); -NODES[2104].Fix(VELOCITY_Y); -NODES[2104].Fix(VELOCITY_Z); -NODES[2105].Fix(VELOCITY_X); -NODES[2105].Fix(VELOCITY_Y); -NODES[2105].Fix(VELOCITY_Z); -NODES[2107].Fix(VELOCITY_X); -NODES[2107].Fix(VELOCITY_Y); -NODES[2107].Fix(VELOCITY_Z); -NODES[2110].Fix(VELOCITY_X); -NODES[2110].Fix(VELOCITY_Y); -NODES[2110].Fix(VELOCITY_Z); -NODES[2111].Fix(VELOCITY_X); -NODES[2111].Fix(VELOCITY_Y); -NODES[2111].Fix(VELOCITY_Z); -NODES[2112].Fix(VELOCITY_X); -NODES[2112].Fix(VELOCITY_Y); -NODES[2112].Fix(VELOCITY_Z); -NODES[2113].Fix(VELOCITY_X); -NODES[2113].Fix(VELOCITY_Y); -NODES[2113].Fix(VELOCITY_Z); -NODES[2115].Fix(VELOCITY_X); -NODES[2115].Fix(VELOCITY_Y); -NODES[2115].Fix(VELOCITY_Z); -NODES[2117].Fix(VELOCITY_X); -NODES[2117].Fix(VELOCITY_Y); -NODES[2117].Fix(VELOCITY_Z); -NODES[2119].Fix(VELOCITY_X); -NODES[2119].Fix(VELOCITY_Y); -NODES[2119].Fix(VELOCITY_Z); -NODES[2120].Fix(VELOCITY_X); -NODES[2120].Fix(VELOCITY_Y); -NODES[2120].Fix(VELOCITY_Z); -NODES[2121].Fix(VELOCITY_X); -NODES[2121].Fix(VELOCITY_Y); -NODES[2121].Fix(VELOCITY_Z); -NODES[2125].Fix(VELOCITY_X); -NODES[2125].Fix(VELOCITY_Y); -NODES[2125].Fix(VELOCITY_Z); -NODES[2127].Fix(VELOCITY_X); -NODES[2127].Fix(VELOCITY_Y); -NODES[2127].Fix(VELOCITY_Z); -NODES[2128].Fix(VELOCITY_X); -NODES[2128].Fix(VELOCITY_Y); -NODES[2128].Fix(VELOCITY_Z); -NODES[2129].Fix(VELOCITY_X); -NODES[2129].Fix(VELOCITY_Y); -NODES[2129].Fix(VELOCITY_Z); -NODES[2131].Fix(VELOCITY_X); -NODES[2131].Fix(VELOCITY_Y); -NODES[2131].Fix(VELOCITY_Z); -NODES[2133].Fix(VELOCITY_X); -NODES[2133].Fix(VELOCITY_Y); -NODES[2133].Fix(VELOCITY_Z); -NODES[2136].Fix(VELOCITY_X); -NODES[2136].Fix(VELOCITY_Y); -NODES[2136].Fix(VELOCITY_Z); -NODES[2138].Fix(VELOCITY_X); -NODES[2138].Fix(VELOCITY_Y); -NODES[2138].Fix(VELOCITY_Z); -NODES[2139].Fix(VELOCITY_X); -NODES[2139].Fix(VELOCITY_Y); -NODES[2139].Fix(VELOCITY_Z); -NODES[2140].Fix(VELOCITY_X); -NODES[2140].Fix(VELOCITY_Y); -NODES[2140].Fix(VELOCITY_Z); -NODES[2145].Fix(VELOCITY_X); -NODES[2145].Fix(VELOCITY_Y); -NODES[2145].Fix(VELOCITY_Z); -NODES[2148].Fix(VELOCITY_X); -NODES[2148].Fix(VELOCITY_Y); -NODES[2148].Fix(VELOCITY_Z); -NODES[2149].Fix(VELOCITY_X); -NODES[2149].Fix(VELOCITY_Y); -NODES[2149].Fix(VELOCITY_Z); -NODES[2150].Fix(VELOCITY_X); -NODES[2150].Fix(VELOCITY_Y); -NODES[2150].Fix(VELOCITY_Z); -NODES[2153].Fix(VELOCITY_X); -NODES[2153].Fix(VELOCITY_Y); -NODES[2153].Fix(VELOCITY_Z); -NODES[2155].Fix(VELOCITY_X); -NODES[2155].Fix(VELOCITY_Y); -NODES[2155].Fix(VELOCITY_Z); -NODES[2158].Fix(VELOCITY_X); -NODES[2158].Fix(VELOCITY_Y); -NODES[2158].Fix(VELOCITY_Z); -NODES[2159].Fix(VELOCITY_X); -NODES[2159].Fix(VELOCITY_Y); -NODES[2159].Fix(VELOCITY_Z); -NODES[2161].Fix(VELOCITY_X); -NODES[2161].Fix(VELOCITY_Y); -NODES[2161].Fix(VELOCITY_Z); -NODES[2164].Fix(VELOCITY_X); -NODES[2164].Fix(VELOCITY_Y); -NODES[2164].Fix(VELOCITY_Z); -NODES[2165].Fix(VELOCITY_X); -NODES[2165].Fix(VELOCITY_Y); -NODES[2165].Fix(VELOCITY_Z); -NODES[2168].Fix(VELOCITY_X); -NODES[2168].Fix(VELOCITY_Y); -NODES[2168].Fix(VELOCITY_Z); -NODES[2169].Fix(VELOCITY_X); -NODES[2169].Fix(VELOCITY_Y); -NODES[2169].Fix(VELOCITY_Z); -NODES[2172].Fix(VELOCITY_X); -NODES[2172].Fix(VELOCITY_Y); -NODES[2172].Fix(VELOCITY_Z); -NODES[2176].Fix(VELOCITY_X); -NODES[2176].Fix(VELOCITY_Y); -NODES[2176].Fix(VELOCITY_Z); -NODES[2177].Fix(VELOCITY_X); -NODES[2177].Fix(VELOCITY_Y); -NODES[2177].Fix(VELOCITY_Z); -NODES[2180].Fix(VELOCITY_X); -NODES[2180].Fix(VELOCITY_Y); -NODES[2180].Fix(VELOCITY_Z); -NODES[2181].Fix(VELOCITY_X); -NODES[2181].Fix(VELOCITY_Y); -NODES[2181].Fix(VELOCITY_Z); -NODES[2183].Fix(VELOCITY_X); -NODES[2183].Fix(VELOCITY_Y); -NODES[2183].Fix(VELOCITY_Z); -NODES[2184].Fix(VELOCITY_X); -NODES[2184].Fix(VELOCITY_Y); -NODES[2184].Fix(VELOCITY_Z); -NODES[2189].Fix(VELOCITY_X); -NODES[2189].Fix(VELOCITY_Y); -NODES[2189].Fix(VELOCITY_Z); -NODES[2190].Fix(VELOCITY_X); -NODES[2190].Fix(VELOCITY_Y); -NODES[2190].Fix(VELOCITY_Z); -NODES[2191].Fix(VELOCITY_X); -NODES[2191].Fix(VELOCITY_Y); -NODES[2191].Fix(VELOCITY_Z); -NODES[2192].Fix(VELOCITY_X); -NODES[2192].Fix(VELOCITY_Y); -NODES[2192].Fix(VELOCITY_Z); -NODES[2195].Fix(VELOCITY_X); -NODES[2195].Fix(VELOCITY_Y); -NODES[2195].Fix(VELOCITY_Z); -NODES[2202].Fix(VELOCITY_X); -NODES[2202].Fix(VELOCITY_Y); -NODES[2202].Fix(VELOCITY_Z); -NODES[2205].Fix(VELOCITY_X); -NODES[2205].Fix(VELOCITY_Y); -NODES[2205].Fix(VELOCITY_Z); -NODES[2208].Fix(VELOCITY_X); -NODES[2208].Fix(VELOCITY_Y); -NODES[2208].Fix(VELOCITY_Z); -NODES[2209].Fix(VELOCITY_X); -NODES[2209].Fix(VELOCITY_Y); -NODES[2209].Fix(VELOCITY_Z); -NODES[2216].Fix(VELOCITY_X); -NODES[2216].Fix(VELOCITY_Y); -NODES[2216].Fix(VELOCITY_Z); -NODES[2217].Fix(VELOCITY_X); -NODES[2217].Fix(VELOCITY_Y); -NODES[2217].Fix(VELOCITY_Z); -NODES[2218].Fix(VELOCITY_X); -NODES[2218].Fix(VELOCITY_Y); -NODES[2218].Fix(VELOCITY_Z); -NODES[2225].Fix(VELOCITY_X); -NODES[2225].Fix(VELOCITY_Y); -NODES[2225].Fix(VELOCITY_Z); -NODES[2227].Fix(VELOCITY_X); -NODES[2227].Fix(VELOCITY_Y); -NODES[2227].Fix(VELOCITY_Z); -NODES[2230].Fix(VELOCITY_X); -NODES[2230].Fix(VELOCITY_Y); -NODES[2230].Fix(VELOCITY_Z); -NODES[2231].Fix(VELOCITY_X); -NODES[2231].Fix(VELOCITY_Y); -NODES[2231].Fix(VELOCITY_Z); -NODES[2236].Fix(VELOCITY_X); -NODES[2236].Fix(VELOCITY_Y); -NODES[2236].Fix(VELOCITY_Z); -NODES[2238].Fix(VELOCITY_X); -NODES[2238].Fix(VELOCITY_Y); -NODES[2238].Fix(VELOCITY_Z); -NODES[2242].Fix(VELOCITY_X); -NODES[2242].Fix(VELOCITY_Y); -NODES[2242].Fix(VELOCITY_Z); -NODES[2244].Fix(VELOCITY_X); -NODES[2244].Fix(VELOCITY_Y); -NODES[2244].Fix(VELOCITY_Z); -NODES[2246].Fix(VELOCITY_X); -NODES[2246].Fix(VELOCITY_Y); -NODES[2246].Fix(VELOCITY_Z); -NODES[2247].Fix(VELOCITY_X); -NODES[2247].Fix(VELOCITY_Y); -NODES[2247].Fix(VELOCITY_Z); -NODES[2251].Fix(VELOCITY_X); -NODES[2251].Fix(VELOCITY_Y); -NODES[2251].Fix(VELOCITY_Z); -NODES[2255].Fix(VELOCITY_X); -NODES[2255].Fix(VELOCITY_Y); -NODES[2255].Fix(VELOCITY_Z); -NODES[2265].Fix(VELOCITY_X); -NODES[2265].Fix(VELOCITY_Y); -NODES[2265].Fix(VELOCITY_Z); -NODES[2268].Fix(VELOCITY_X); -NODES[2268].Fix(VELOCITY_Y); -NODES[2268].Fix(VELOCITY_Z); -NODES[2274].Fix(VELOCITY_X); -NODES[2274].Fix(VELOCITY_Y); -NODES[2274].Fix(VELOCITY_Z); -NODES[2277].Fix(VELOCITY_X); -NODES[2277].Fix(VELOCITY_Y); -NODES[2277].Fix(VELOCITY_Z); -NODES[2278].Fix(VELOCITY_X); -NODES[2278].Fix(VELOCITY_Y); -NODES[2278].Fix(VELOCITY_Z); -NODES[2284].Fix(VELOCITY_X); -NODES[2284].Fix(VELOCITY_Y); -NODES[2284].Fix(VELOCITY_Z); -NODES[2285].Fix(VELOCITY_X); -NODES[2285].Fix(VELOCITY_Y); -NODES[2285].Fix(VELOCITY_Z); -NODES[2286].Fix(VELOCITY_X); -NODES[2286].Fix(VELOCITY_Y); -NODES[2286].Fix(VELOCITY_Z); -NODES[2293].Fix(VELOCITY_X); -NODES[2293].Fix(VELOCITY_Y); -NODES[2293].Fix(VELOCITY_Z); -NODES[2295].Fix(VELOCITY_X); -NODES[2295].Fix(VELOCITY_Y); -NODES[2295].Fix(VELOCITY_Z); -NODES[2297].Fix(VELOCITY_X); -NODES[2297].Fix(VELOCITY_Y); -NODES[2297].Fix(VELOCITY_Z); -NODES[2299].Fix(VELOCITY_X); -NODES[2299].Fix(VELOCITY_Y); -NODES[2299].Fix(VELOCITY_Z); -NODES[2302].Fix(VELOCITY_X); -NODES[2302].Fix(VELOCITY_Y); -NODES[2302].Fix(VELOCITY_Z); -NODES[2303].Fix(VELOCITY_X); -NODES[2303].Fix(VELOCITY_Y); -NODES[2303].Fix(VELOCITY_Z); -NODES[2304].Fix(VELOCITY_X); -NODES[2304].Fix(VELOCITY_Y); -NODES[2304].Fix(VELOCITY_Z); -NODES[2305].Fix(VELOCITY_X); -NODES[2305].Fix(VELOCITY_Y); -NODES[2305].Fix(VELOCITY_Z); -NODES[2306].Fix(VELOCITY_X); -NODES[2306].Fix(VELOCITY_Y); -NODES[2306].Fix(VELOCITY_Z); -NODES[2307].Fix(VELOCITY_X); -NODES[2307].Fix(VELOCITY_Y); -NODES[2307].Fix(VELOCITY_Z); -NODES[2308].Fix(VELOCITY_X); -NODES[2308].Fix(VELOCITY_Y); -NODES[2308].Fix(VELOCITY_Z); -NODES[2309].Fix(VELOCITY_X); -NODES[2309].Fix(VELOCITY_Y); -NODES[2309].Fix(VELOCITY_Z); -NODES[2315].Fix(VELOCITY_X); -NODES[2315].Fix(VELOCITY_Y); -NODES[2315].Fix(VELOCITY_Z); -NODES[2316].Fix(VELOCITY_X); -NODES[2316].Fix(VELOCITY_Y); -NODES[2316].Fix(VELOCITY_Z); -NODES[2321].Fix(VELOCITY_X); -NODES[2321].Fix(VELOCITY_Y); -NODES[2321].Fix(VELOCITY_Z); -NODES[2323].Fix(VELOCITY_X); -NODES[2323].Fix(VELOCITY_Y); -NODES[2323].Fix(VELOCITY_Z); -NODES[2324].Fix(VELOCITY_X); -NODES[2324].Fix(VELOCITY_Y); -NODES[2324].Fix(VELOCITY_Z); -NODES[2325].Fix(VELOCITY_X); -NODES[2325].Fix(VELOCITY_Y); -NODES[2325].Fix(VELOCITY_Z); -NODES[2328].Fix(VELOCITY_X); -NODES[2328].Fix(VELOCITY_Y); -NODES[2328].Fix(VELOCITY_Z); -NODES[2329].Fix(VELOCITY_X); -NODES[2329].Fix(VELOCITY_Y); -NODES[2329].Fix(VELOCITY_Z); -NODES[2330].Fix(VELOCITY_X); -NODES[2330].Fix(VELOCITY_Y); -NODES[2330].Fix(VELOCITY_Z); -NODES[2331].Fix(VELOCITY_X); -NODES[2331].Fix(VELOCITY_Y); -NODES[2331].Fix(VELOCITY_Z); -NODES[2332].Fix(VELOCITY_X); -NODES[2332].Fix(VELOCITY_Y); -NODES[2332].Fix(VELOCITY_Z); -NODES[2333].Fix(VELOCITY_X); -NODES[2333].Fix(VELOCITY_Y); -NODES[2333].Fix(VELOCITY_Z); -NODES[2335].Fix(VELOCITY_X); -NODES[2335].Fix(VELOCITY_Y); -NODES[2335].Fix(VELOCITY_Z); -NODES[2336].Fix(VELOCITY_X); -NODES[2336].Fix(VELOCITY_Y); -NODES[2336].Fix(VELOCITY_Z); -NODES[2345].Fix(VELOCITY_X); -NODES[2345].Fix(VELOCITY_Y); -NODES[2345].Fix(VELOCITY_Z); -NODES[2347].Fix(VELOCITY_X); -NODES[2347].Fix(VELOCITY_Y); -NODES[2347].Fix(VELOCITY_Z); -NODES[2348].Fix(VELOCITY_X); -NODES[2348].Fix(VELOCITY_Y); -NODES[2348].Fix(VELOCITY_Z); -NODES[2351].Fix(VELOCITY_X); -NODES[2351].Fix(VELOCITY_Y); -NODES[2351].Fix(VELOCITY_Z); -NODES[2356].Fix(VELOCITY_X); -NODES[2356].Fix(VELOCITY_Y); -NODES[2356].Fix(VELOCITY_Z); -NODES[2358].Fix(VELOCITY_X); -NODES[2358].Fix(VELOCITY_Y); -NODES[2358].Fix(VELOCITY_Z); -NODES[2359].Fix(VELOCITY_X); -NODES[2359].Fix(VELOCITY_Y); -NODES[2359].Fix(VELOCITY_Z); -NODES[2360].Fix(VELOCITY_X); -NODES[2360].Fix(VELOCITY_Y); -NODES[2360].Fix(VELOCITY_Z); -NODES[2361].Fix(VELOCITY_X); -NODES[2361].Fix(VELOCITY_Y); -NODES[2361].Fix(VELOCITY_Z); -NODES[2362].Fix(VELOCITY_X); -NODES[2362].Fix(VELOCITY_Y); -NODES[2362].Fix(VELOCITY_Z); -NODES[2363].Fix(VELOCITY_X); -NODES[2363].Fix(VELOCITY_Y); -NODES[2363].Fix(VELOCITY_Z); -NODES[2369].Fix(VELOCITY_X); -NODES[2369].Fix(VELOCITY_Y); -NODES[2369].Fix(VELOCITY_Z); -NODES[2370].Fix(VELOCITY_X); -NODES[2370].Fix(VELOCITY_Y); -NODES[2370].Fix(VELOCITY_Z); -NODES[2371].Fix(VELOCITY_X); -NODES[2371].Fix(VELOCITY_Y); -NODES[2371].Fix(VELOCITY_Z); -NODES[2375].Fix(VELOCITY_X); -NODES[2375].Fix(VELOCITY_Y); -NODES[2375].Fix(VELOCITY_Z); -NODES[2376].Fix(VELOCITY_X); -NODES[2376].Fix(VELOCITY_Y); -NODES[2376].Fix(VELOCITY_Z); -NODES[2377].Fix(VELOCITY_X); -NODES[2377].Fix(VELOCITY_Y); -NODES[2377].Fix(VELOCITY_Z); -NODES[2382].Fix(VELOCITY_X); -NODES[2382].Fix(VELOCITY_Y); -NODES[2382].Fix(VELOCITY_Z); -NODES[2388].Fix(VELOCITY_X); -NODES[2388].Fix(VELOCITY_Y); -NODES[2388].Fix(VELOCITY_Z); -NODES[2392].Fix(VELOCITY_X); -NODES[2392].Fix(VELOCITY_Y); -NODES[2392].Fix(VELOCITY_Z); -NODES[2393].Fix(VELOCITY_X); -NODES[2393].Fix(VELOCITY_Y); -NODES[2393].Fix(VELOCITY_Z); -NODES[2395].Fix(VELOCITY_X); -NODES[2395].Fix(VELOCITY_Y); -NODES[2395].Fix(VELOCITY_Z); -NODES[2397].Fix(VELOCITY_X); -NODES[2397].Fix(VELOCITY_Y); -NODES[2397].Fix(VELOCITY_Z); -NODES[2399].Fix(VELOCITY_X); -NODES[2399].Fix(VELOCITY_Y); -NODES[2399].Fix(VELOCITY_Z); -NODES[2405].Fix(VELOCITY_X); -NODES[2405].Fix(VELOCITY_Y); -NODES[2405].Fix(VELOCITY_Z); -NODES[2411].Fix(VELOCITY_X); -NODES[2411].Fix(VELOCITY_Y); -NODES[2411].Fix(VELOCITY_Z); -NODES[2412].Fix(VELOCITY_X); -NODES[2412].Fix(VELOCITY_Y); -NODES[2412].Fix(VELOCITY_Z); -NODES[2418].Fix(VELOCITY_X); -NODES[2418].Fix(VELOCITY_Y); -NODES[2418].Fix(VELOCITY_Z); -NODES[2424].Fix(VELOCITY_X); -NODES[2424].Fix(VELOCITY_Y); -NODES[2424].Fix(VELOCITY_Z); -NODES[2428].Fix(VELOCITY_X); -NODES[2428].Fix(VELOCITY_Y); -NODES[2428].Fix(VELOCITY_Z); -NODES[2429].Fix(VELOCITY_X); -NODES[2429].Fix(VELOCITY_Y); -NODES[2429].Fix(VELOCITY_Z); -NODES[2430].Fix(VELOCITY_X); -NODES[2430].Fix(VELOCITY_Y); -NODES[2430].Fix(VELOCITY_Z); -NODES[2434].Fix(VELOCITY_X); -NODES[2434].Fix(VELOCITY_Y); -NODES[2434].Fix(VELOCITY_Z); -NODES[2435].Fix(VELOCITY_X); -NODES[2435].Fix(VELOCITY_Y); -NODES[2435].Fix(VELOCITY_Z); -NODES[2443].Fix(VELOCITY_X); -NODES[2443].Fix(VELOCITY_Y); -NODES[2443].Fix(VELOCITY_Z); -NODES[2446].Fix(VELOCITY_X); -NODES[2446].Fix(VELOCITY_Y); -NODES[2446].Fix(VELOCITY_Z); -NODES[2452].Fix(VELOCITY_X); -NODES[2452].Fix(VELOCITY_Y); -NODES[2452].Fix(VELOCITY_Z); -NODES[2457].Fix(VELOCITY_X); -NODES[2457].Fix(VELOCITY_Y); -NODES[2457].Fix(VELOCITY_Z); -NODES[2458].Fix(VELOCITY_X); -NODES[2458].Fix(VELOCITY_Y); -NODES[2458].Fix(VELOCITY_Z); -NODES[2459].Fix(VELOCITY_X); -NODES[2459].Fix(VELOCITY_Y); -NODES[2459].Fix(VELOCITY_Z); -NODES[2461].Fix(VELOCITY_X); -NODES[2461].Fix(VELOCITY_Y); -NODES[2461].Fix(VELOCITY_Z); -NODES[2462].Fix(VELOCITY_X); -NODES[2462].Fix(VELOCITY_Y); -NODES[2462].Fix(VELOCITY_Z); -NODES[2470].Fix(VELOCITY_X); -NODES[2470].Fix(VELOCITY_Y); -NODES[2470].Fix(VELOCITY_Z); -NODES[2472].Fix(VELOCITY_X); -NODES[2472].Fix(VELOCITY_Y); -NODES[2472].Fix(VELOCITY_Z); -NODES[2473].Fix(VELOCITY_X); -NODES[2473].Fix(VELOCITY_Y); -NODES[2473].Fix(VELOCITY_Z); -NODES[2478].Fix(VELOCITY_X); -NODES[2478].Fix(VELOCITY_Y); -NODES[2478].Fix(VELOCITY_Z); -NODES[2479].Fix(VELOCITY_X); -NODES[2479].Fix(VELOCITY_Y); -NODES[2479].Fix(VELOCITY_Z); -NODES[2488].Fix(VELOCITY_X); -NODES[2488].Fix(VELOCITY_Y); -NODES[2488].Fix(VELOCITY_Z); -NODES[2489].Fix(VELOCITY_X); -NODES[2489].Fix(VELOCITY_Y); -NODES[2489].Fix(VELOCITY_Z); -NODES[2492].Fix(VELOCITY_X); -NODES[2492].Fix(VELOCITY_Y); -NODES[2492].Fix(VELOCITY_Z); -NODES[2499].Fix(VELOCITY_X); -NODES[2499].Fix(VELOCITY_Y); -NODES[2499].Fix(VELOCITY_Z); -NODES[2505].Fix(VELOCITY_X); -NODES[2505].Fix(VELOCITY_Y); -NODES[2505].Fix(VELOCITY_Z); -NODES[2506].Fix(VELOCITY_X); -NODES[2506].Fix(VELOCITY_Y); -NODES[2506].Fix(VELOCITY_Z); -NODES[2508].Fix(VELOCITY_X); -NODES[2508].Fix(VELOCITY_Y); -NODES[2508].Fix(VELOCITY_Z); -NODES[2510].Fix(VELOCITY_X); -NODES[2510].Fix(VELOCITY_Y); -NODES[2510].Fix(VELOCITY_Z); -NODES[2513].Fix(VELOCITY_X); -NODES[2513].Fix(VELOCITY_Y); -NODES[2513].Fix(VELOCITY_Z); -NODES[2515].Fix(VELOCITY_X); -NODES[2515].Fix(VELOCITY_Y); -NODES[2515].Fix(VELOCITY_Z); -NODES[2519].Fix(VELOCITY_X); -NODES[2519].Fix(VELOCITY_Y); -NODES[2519].Fix(VELOCITY_Z); -NODES[2521].Fix(VELOCITY_X); -NODES[2521].Fix(VELOCITY_Y); -NODES[2521].Fix(VELOCITY_Z); -NODES[2525].Fix(VELOCITY_X); -NODES[2525].Fix(VELOCITY_Y); -NODES[2525].Fix(VELOCITY_Z); -NODES[2526].Fix(VELOCITY_X); -NODES[2526].Fix(VELOCITY_Y); -NODES[2526].Fix(VELOCITY_Z); -NODES[2530].Fix(VELOCITY_X); -NODES[2530].Fix(VELOCITY_Y); -NODES[2530].Fix(VELOCITY_Z); -NODES[2533].Fix(VELOCITY_X); -NODES[2533].Fix(VELOCITY_Y); -NODES[2533].Fix(VELOCITY_Z); -NODES[2540].Fix(VELOCITY_X); -NODES[2540].Fix(VELOCITY_Y); -NODES[2540].Fix(VELOCITY_Z); -NODES[2543].Fix(VELOCITY_X); -NODES[2543].Fix(VELOCITY_Y); -NODES[2543].Fix(VELOCITY_Z); -NODES[2545].Fix(VELOCITY_X); -NODES[2545].Fix(VELOCITY_Y); -NODES[2545].Fix(VELOCITY_Z); -NODES[2549].Fix(VELOCITY_X); -NODES[2549].Fix(VELOCITY_Y); -NODES[2549].Fix(VELOCITY_Z); -NODES[2551].Fix(VELOCITY_X); -NODES[2551].Fix(VELOCITY_Y); -NODES[2551].Fix(VELOCITY_Z); -NODES[2552].Fix(VELOCITY_X); -NODES[2552].Fix(VELOCITY_Y); -NODES[2552].Fix(VELOCITY_Z); -NODES[2554].Fix(VELOCITY_X); -NODES[2554].Fix(VELOCITY_Y); -NODES[2554].Fix(VELOCITY_Z); -NODES[2559].Fix(VELOCITY_X); -NODES[2559].Fix(VELOCITY_Y); -NODES[2559].Fix(VELOCITY_Z); -NODES[2560].Fix(VELOCITY_X); -NODES[2560].Fix(VELOCITY_Y); -NODES[2560].Fix(VELOCITY_Z); -NODES[2571].Fix(VELOCITY_X); -NODES[2571].Fix(VELOCITY_Y); -NODES[2571].Fix(VELOCITY_Z); -NODES[2573].Fix(VELOCITY_X); -NODES[2573].Fix(VELOCITY_Y); -NODES[2573].Fix(VELOCITY_Z); -NODES[2574].Fix(VELOCITY_X); -NODES[2574].Fix(VELOCITY_Y); -NODES[2574].Fix(VELOCITY_Z); -NODES[2575].Fix(VELOCITY_X); -NODES[2575].Fix(VELOCITY_Y); -NODES[2575].Fix(VELOCITY_Z); -NODES[2576].Fix(VELOCITY_X); -NODES[2576].Fix(VELOCITY_Y); -NODES[2576].Fix(VELOCITY_Z); -NODES[2579].Fix(VELOCITY_X); -NODES[2579].Fix(VELOCITY_Y); -NODES[2579].Fix(VELOCITY_Z); -NODES[2580].Fix(VELOCITY_X); -NODES[2580].Fix(VELOCITY_Y); -NODES[2580].Fix(VELOCITY_Z); -NODES[2584].Fix(VELOCITY_X); -NODES[2584].Fix(VELOCITY_Y); -NODES[2584].Fix(VELOCITY_Z); -NODES[2585].Fix(VELOCITY_X); -NODES[2585].Fix(VELOCITY_Y); -NODES[2585].Fix(VELOCITY_Z); -NODES[2587].Fix(VELOCITY_X); -NODES[2587].Fix(VELOCITY_Y); -NODES[2587].Fix(VELOCITY_Z); -NODES[2589].Fix(VELOCITY_X); -NODES[2589].Fix(VELOCITY_Y); -NODES[2589].Fix(VELOCITY_Z); -NODES[2591].Fix(VELOCITY_X); -NODES[2591].Fix(VELOCITY_Y); -NODES[2591].Fix(VELOCITY_Z); -NODES[2596].Fix(VELOCITY_X); -NODES[2596].Fix(VELOCITY_Y); -NODES[2596].Fix(VELOCITY_Z); -NODES[2597].Fix(VELOCITY_X); -NODES[2597].Fix(VELOCITY_Y); -NODES[2597].Fix(VELOCITY_Z); -NODES[2599].Fix(VELOCITY_X); -NODES[2599].Fix(VELOCITY_Y); -NODES[2599].Fix(VELOCITY_Z); -NODES[2600].Fix(VELOCITY_X); -NODES[2600].Fix(VELOCITY_Y); -NODES[2600].Fix(VELOCITY_Z); -NODES[2603].Fix(VELOCITY_X); -NODES[2603].Fix(VELOCITY_Y); -NODES[2603].Fix(VELOCITY_Z); -NODES[2604].Fix(VELOCITY_X); -NODES[2604].Fix(VELOCITY_Y); -NODES[2604].Fix(VELOCITY_Z); -NODES[2608].Fix(VELOCITY_X); -NODES[2608].Fix(VELOCITY_Y); -NODES[2608].Fix(VELOCITY_Z); -NODES[2612].Fix(VELOCITY_X); -NODES[2612].Fix(VELOCITY_Y); -NODES[2612].Fix(VELOCITY_Z); -NODES[2617].Fix(VELOCITY_X); -NODES[2617].Fix(VELOCITY_Y); -NODES[2617].Fix(VELOCITY_Z); -NODES[2621].Fix(VELOCITY_X); -NODES[2621].Fix(VELOCITY_Y); -NODES[2621].Fix(VELOCITY_Z); -NODES[2622].Fix(VELOCITY_X); -NODES[2622].Fix(VELOCITY_Y); -NODES[2622].Fix(VELOCITY_Z); -NODES[2624].Fix(VELOCITY_X); -NODES[2624].Fix(VELOCITY_Y); -NODES[2624].Fix(VELOCITY_Z); -NODES[2625].Fix(VELOCITY_X); -NODES[2625].Fix(VELOCITY_Y); -NODES[2625].Fix(VELOCITY_Z); -NODES[2629].Fix(VELOCITY_X); -NODES[2629].Fix(VELOCITY_Y); -NODES[2629].Fix(VELOCITY_Z); -NODES[2631].Fix(VELOCITY_X); -NODES[2631].Fix(VELOCITY_Y); -NODES[2631].Fix(VELOCITY_Z); -NODES[2632].Fix(VELOCITY_X); -NODES[2632].Fix(VELOCITY_Y); -NODES[2632].Fix(VELOCITY_Z); -NODES[2633].Fix(VELOCITY_X); -NODES[2633].Fix(VELOCITY_Y); -NODES[2633].Fix(VELOCITY_Z); -NODES[2643].Fix(VELOCITY_X); -NODES[2643].Fix(VELOCITY_Y); -NODES[2643].Fix(VELOCITY_Z); -NODES[2645].Fix(VELOCITY_X); -NODES[2645].Fix(VELOCITY_Y); -NODES[2645].Fix(VELOCITY_Z); -NODES[2646].Fix(VELOCITY_X); -NODES[2646].Fix(VELOCITY_Y); -NODES[2646].Fix(VELOCITY_Z); -NODES[2656].Fix(VELOCITY_X); -NODES[2656].Fix(VELOCITY_Y); -NODES[2656].Fix(VELOCITY_Z); -NODES[2657].Fix(VELOCITY_X); -NODES[2657].Fix(VELOCITY_Y); -NODES[2657].Fix(VELOCITY_Z); -NODES[2658].Fix(VELOCITY_X); -NODES[2658].Fix(VELOCITY_Y); -NODES[2658].Fix(VELOCITY_Z); -NODES[2661].Fix(VELOCITY_X); -NODES[2661].Fix(VELOCITY_Y); -NODES[2661].Fix(VELOCITY_Z); -NODES[2663].Fix(VELOCITY_X); -NODES[2663].Fix(VELOCITY_Y); -NODES[2663].Fix(VELOCITY_Z); -NODES[2668].Fix(VELOCITY_X); -NODES[2668].Fix(VELOCITY_Y); -NODES[2668].Fix(VELOCITY_Z); -NODES[2669].Fix(VELOCITY_X); -NODES[2669].Fix(VELOCITY_Y); -NODES[2669].Fix(VELOCITY_Z); -NODES[2678].Fix(VELOCITY_X); -NODES[2678].Fix(VELOCITY_Y); -NODES[2678].Fix(VELOCITY_Z); -NODES[2679].Fix(VELOCITY_X); -NODES[2679].Fix(VELOCITY_Y); -NODES[2679].Fix(VELOCITY_Z); -NODES[2684].Fix(VELOCITY_X); -NODES[2684].Fix(VELOCITY_Y); -NODES[2684].Fix(VELOCITY_Z); -NODES[2685].Fix(VELOCITY_X); -NODES[2685].Fix(VELOCITY_Y); -NODES[2685].Fix(VELOCITY_Z); -NODES[2690].Fix(VELOCITY_X); -NODES[2690].Fix(VELOCITY_Y); -NODES[2690].Fix(VELOCITY_Z); -NODES[2691].Fix(VELOCITY_X); -NODES[2691].Fix(VELOCITY_Y); -NODES[2691].Fix(VELOCITY_Z); -NODES[2693].Fix(VELOCITY_X); -NODES[2693].Fix(VELOCITY_Y); -NODES[2693].Fix(VELOCITY_Z); -NODES[2698].Fix(VELOCITY_X); -NODES[2698].Fix(VELOCITY_Y); -NODES[2698].Fix(VELOCITY_Z); -NODES[2702].Fix(VELOCITY_X); -NODES[2702].Fix(VELOCITY_Y); -NODES[2702].Fix(VELOCITY_Z); -NODES[2707].Fix(VELOCITY_X); -NODES[2707].Fix(VELOCITY_Y); -NODES[2707].Fix(VELOCITY_Z); -NODES[2712].Fix(VELOCITY_X); -NODES[2712].Fix(VELOCITY_Y); -NODES[2712].Fix(VELOCITY_Z); -NODES[2726].Fix(VELOCITY_X); -NODES[2726].Fix(VELOCITY_Y); -NODES[2726].Fix(VELOCITY_Z); -NODES[2730].Fix(VELOCITY_X); -NODES[2730].Fix(VELOCITY_Y); -NODES[2730].Fix(VELOCITY_Z); -NODES[2731].Fix(VELOCITY_X); -NODES[2731].Fix(VELOCITY_Y); -NODES[2731].Fix(VELOCITY_Z); -NODES[2732].Fix(VELOCITY_X); -NODES[2732].Fix(VELOCITY_Y); -NODES[2732].Fix(VELOCITY_Z); -NODES[2737].Fix(VELOCITY_X); -NODES[2737].Fix(VELOCITY_Y); -NODES[2737].Fix(VELOCITY_Z); -NODES[2754].Fix(VELOCITY_X); -NODES[2754].Fix(VELOCITY_Y); -NODES[2754].Fix(VELOCITY_Z); -NODES[2755].Fix(VELOCITY_X); -NODES[2755].Fix(VELOCITY_Y); -NODES[2755].Fix(VELOCITY_Z); -NODES[2757].Fix(VELOCITY_X); -NODES[2757].Fix(VELOCITY_Y); -NODES[2757].Fix(VELOCITY_Z); -NODES[2758].Fix(VELOCITY_X); -NODES[2758].Fix(VELOCITY_Y); -NODES[2758].Fix(VELOCITY_Z); -NODES[2759].Fix(VELOCITY_X); -NODES[2759].Fix(VELOCITY_Y); -NODES[2759].Fix(VELOCITY_Z); -NODES[2764].Fix(VELOCITY_X); -NODES[2764].Fix(VELOCITY_Y); -NODES[2764].Fix(VELOCITY_Z); -NODES[2766].Fix(VELOCITY_X); -NODES[2766].Fix(VELOCITY_Y); -NODES[2766].Fix(VELOCITY_Z); -NODES[2769].Fix(VELOCITY_X); -NODES[2769].Fix(VELOCITY_Y); -NODES[2769].Fix(VELOCITY_Z); -NODES[2773].Fix(VELOCITY_X); -NODES[2773].Fix(VELOCITY_Y); -NODES[2773].Fix(VELOCITY_Z); -NODES[2780].Fix(VELOCITY_X); -NODES[2780].Fix(VELOCITY_Y); -NODES[2780].Fix(VELOCITY_Z); -NODES[2782].Fix(VELOCITY_X); -NODES[2782].Fix(VELOCITY_Y); -NODES[2782].Fix(VELOCITY_Z); -NODES[2785].Fix(VELOCITY_X); -NODES[2785].Fix(VELOCITY_Y); -NODES[2785].Fix(VELOCITY_Z); -NODES[2786].Fix(VELOCITY_X); -NODES[2786].Fix(VELOCITY_Y); -NODES[2786].Fix(VELOCITY_Z); -NODES[2787].Fix(VELOCITY_X); -NODES[2787].Fix(VELOCITY_Y); -NODES[2787].Fix(VELOCITY_Z); -NODES[2790].Fix(VELOCITY_X); -NODES[2790].Fix(VELOCITY_Y); -NODES[2790].Fix(VELOCITY_Z); -NODES[2791].Fix(VELOCITY_X); -NODES[2791].Fix(VELOCITY_Y); -NODES[2791].Fix(VELOCITY_Z); -NODES[2795].Fix(VELOCITY_X); -NODES[2795].Fix(VELOCITY_Y); -NODES[2795].Fix(VELOCITY_Z); -NODES[2796].Fix(VELOCITY_X); -NODES[2796].Fix(VELOCITY_Y); -NODES[2796].Fix(VELOCITY_Z); -NODES[2802].Fix(VELOCITY_X); -NODES[2802].Fix(VELOCITY_Y); -NODES[2802].Fix(VELOCITY_Z); -NODES[2807].Fix(VELOCITY_X); -NODES[2807].Fix(VELOCITY_Y); -NODES[2807].Fix(VELOCITY_Z); -NODES[2809].Fix(VELOCITY_X); -NODES[2809].Fix(VELOCITY_Y); -NODES[2809].Fix(VELOCITY_Z); -NODES[2810].Fix(VELOCITY_X); -NODES[2810].Fix(VELOCITY_Y); -NODES[2810].Fix(VELOCITY_Z); -NODES[2814].Fix(VELOCITY_X); -NODES[2814].Fix(VELOCITY_Y); -NODES[2814].Fix(VELOCITY_Z); -NODES[2815].Fix(VELOCITY_X); -NODES[2815].Fix(VELOCITY_Y); -NODES[2815].Fix(VELOCITY_Z); -NODES[2821].Fix(VELOCITY_X); -NODES[2821].Fix(VELOCITY_Y); -NODES[2821].Fix(VELOCITY_Z); -NODES[2822].Fix(VELOCITY_X); -NODES[2822].Fix(VELOCITY_Y); -NODES[2822].Fix(VELOCITY_Z); -NODES[2824].Fix(VELOCITY_X); -NODES[2824].Fix(VELOCITY_Y); -NODES[2824].Fix(VELOCITY_Z); -NODES[2829].Fix(VELOCITY_X); -NODES[2829].Fix(VELOCITY_Y); -NODES[2829].Fix(VELOCITY_Z); -NODES[2837].Fix(VELOCITY_X); -NODES[2837].Fix(VELOCITY_Y); -NODES[2837].Fix(VELOCITY_Z); -NODES[2839].Fix(VELOCITY_X); -NODES[2839].Fix(VELOCITY_Y); -NODES[2839].Fix(VELOCITY_Z); -NODES[2848].Fix(VELOCITY_X); -NODES[2848].Fix(VELOCITY_Y); -NODES[2848].Fix(VELOCITY_Z); -NODES[2850].Fix(VELOCITY_X); -NODES[2850].Fix(VELOCITY_Y); -NODES[2850].Fix(VELOCITY_Z); -NODES[2856].Fix(VELOCITY_X); -NODES[2856].Fix(VELOCITY_Y); -NODES[2856].Fix(VELOCITY_Z); -NODES[2857].Fix(VELOCITY_X); -NODES[2857].Fix(VELOCITY_Y); -NODES[2857].Fix(VELOCITY_Z); -NODES[2861].Fix(VELOCITY_X); -NODES[2861].Fix(VELOCITY_Y); -NODES[2861].Fix(VELOCITY_Z); -NODES[2862].Fix(VELOCITY_X); -NODES[2862].Fix(VELOCITY_Y); -NODES[2862].Fix(VELOCITY_Z); -NODES[2867].Fix(VELOCITY_X); -NODES[2867].Fix(VELOCITY_Y); -NODES[2867].Fix(VELOCITY_Z); -NODES[2873].Fix(VELOCITY_X); -NODES[2873].Fix(VELOCITY_Y); -NODES[2873].Fix(VELOCITY_Z); -NODES[2874].Fix(VELOCITY_X); -NODES[2874].Fix(VELOCITY_Y); -NODES[2874].Fix(VELOCITY_Z); -NODES[2877].Fix(VELOCITY_X); -NODES[2877].Fix(VELOCITY_Y); -NODES[2877].Fix(VELOCITY_Z); -NODES[2879].Fix(VELOCITY_X); -NODES[2879].Fix(VELOCITY_Y); -NODES[2879].Fix(VELOCITY_Z); -NODES[2887].Fix(VELOCITY_X); -NODES[2887].Fix(VELOCITY_Y); -NODES[2887].Fix(VELOCITY_Z); -NODES[2893].Fix(VELOCITY_X); -NODES[2893].Fix(VELOCITY_Y); -NODES[2893].Fix(VELOCITY_Z); -NODES[2894].Fix(VELOCITY_X); -NODES[2894].Fix(VELOCITY_Y); -NODES[2894].Fix(VELOCITY_Z); -NODES[2896].Fix(VELOCITY_X); -NODES[2896].Fix(VELOCITY_Y); -NODES[2896].Fix(VELOCITY_Z); -NODES[2897].Fix(VELOCITY_X); -NODES[2897].Fix(VELOCITY_Y); -NODES[2897].Fix(VELOCITY_Z); -NODES[2901].Fix(VELOCITY_X); -NODES[2901].Fix(VELOCITY_Y); -NODES[2901].Fix(VELOCITY_Z); -NODES[2903].Fix(VELOCITY_X); -NODES[2903].Fix(VELOCITY_Y); -NODES[2903].Fix(VELOCITY_Z); -NODES[2907].Fix(VELOCITY_X); -NODES[2907].Fix(VELOCITY_Y); -NODES[2907].Fix(VELOCITY_Z); -NODES[2908].Fix(VELOCITY_X); -NODES[2908].Fix(VELOCITY_Y); -NODES[2908].Fix(VELOCITY_Z); -NODES[2909].Fix(VELOCITY_X); -NODES[2909].Fix(VELOCITY_Y); -NODES[2909].Fix(VELOCITY_Z); -NODES[2915].Fix(VELOCITY_X); -NODES[2915].Fix(VELOCITY_Y); -NODES[2915].Fix(VELOCITY_Z); -NODES[2918].Fix(VELOCITY_X); -NODES[2918].Fix(VELOCITY_Y); -NODES[2918].Fix(VELOCITY_Z); -NODES[2921].Fix(VELOCITY_X); -NODES[2921].Fix(VELOCITY_Y); -NODES[2921].Fix(VELOCITY_Z); -NODES[2922].Fix(VELOCITY_X); -NODES[2922].Fix(VELOCITY_Y); -NODES[2922].Fix(VELOCITY_Z); -NODES[2923].Fix(VELOCITY_X); -NODES[2923].Fix(VELOCITY_Y); -NODES[2923].Fix(VELOCITY_Z); -NODES[2929].Fix(VELOCITY_X); -NODES[2929].Fix(VELOCITY_Y); -NODES[2929].Fix(VELOCITY_Z); -NODES[2933].Fix(VELOCITY_X); -NODES[2933].Fix(VELOCITY_Y); -NODES[2933].Fix(VELOCITY_Z); -NODES[2934].Fix(VELOCITY_X); -NODES[2934].Fix(VELOCITY_Y); -NODES[2934].Fix(VELOCITY_Z); -NODES[2937].Fix(VELOCITY_X); -NODES[2937].Fix(VELOCITY_Y); -NODES[2937].Fix(VELOCITY_Z); -NODES[2939].Fix(VELOCITY_X); -NODES[2939].Fix(VELOCITY_Y); -NODES[2939].Fix(VELOCITY_Z); -NODES[2942].Fix(VELOCITY_X); -NODES[2942].Fix(VELOCITY_Y); -NODES[2942].Fix(VELOCITY_Z); -NODES[2950].Fix(VELOCITY_X); -NODES[2950].Fix(VELOCITY_Y); -NODES[2950].Fix(VELOCITY_Z); -NODES[2951].Fix(VELOCITY_X); -NODES[2951].Fix(VELOCITY_Y); -NODES[2951].Fix(VELOCITY_Z); -NODES[2958].Fix(VELOCITY_X); -NODES[2958].Fix(VELOCITY_Y); -NODES[2958].Fix(VELOCITY_Z); -NODES[2966].Fix(VELOCITY_X); -NODES[2966].Fix(VELOCITY_Y); -NODES[2966].Fix(VELOCITY_Z); -NODES[2967].Fix(VELOCITY_X); -NODES[2967].Fix(VELOCITY_Y); -NODES[2967].Fix(VELOCITY_Z); -NODES[2968].Fix(VELOCITY_X); -NODES[2968].Fix(VELOCITY_Y); -NODES[2968].Fix(VELOCITY_Z); -NODES[2972].Fix(VELOCITY_X); -NODES[2972].Fix(VELOCITY_Y); -NODES[2972].Fix(VELOCITY_Z); -NODES[2975].Fix(VELOCITY_X); -NODES[2975].Fix(VELOCITY_Y); -NODES[2975].Fix(VELOCITY_Z); -NODES[2977].Fix(VELOCITY_X); -NODES[2977].Fix(VELOCITY_Y); -NODES[2977].Fix(VELOCITY_Z); -NODES[2982].Fix(VELOCITY_X); -NODES[2982].Fix(VELOCITY_Y); -NODES[2982].Fix(VELOCITY_Z); -NODES[2983].Fix(VELOCITY_X); -NODES[2983].Fix(VELOCITY_Y); -NODES[2983].Fix(VELOCITY_Z); -NODES[2990].Fix(VELOCITY_X); -NODES[2990].Fix(VELOCITY_Y); -NODES[2990].Fix(VELOCITY_Z); -NODES[2991].Fix(VELOCITY_X); -NODES[2991].Fix(VELOCITY_Y); -NODES[2991].Fix(VELOCITY_Z); -NODES[2992].Fix(VELOCITY_X); -NODES[2992].Fix(VELOCITY_Y); -NODES[2992].Fix(VELOCITY_Z); -NODES[3001].Fix(VELOCITY_X); -NODES[3001].Fix(VELOCITY_Y); -NODES[3001].Fix(VELOCITY_Z); -NODES[3003].Fix(VELOCITY_X); -NODES[3003].Fix(VELOCITY_Y); -NODES[3003].Fix(VELOCITY_Z); -NODES[3004].Fix(VELOCITY_X); -NODES[3004].Fix(VELOCITY_Y); -NODES[3004].Fix(VELOCITY_Z); -NODES[3005].Fix(VELOCITY_X); -NODES[3005].Fix(VELOCITY_Y); -NODES[3005].Fix(VELOCITY_Z); -NODES[3006].Fix(VELOCITY_X); -NODES[3006].Fix(VELOCITY_Y); -NODES[3006].Fix(VELOCITY_Z); -NODES[3021].Fix(VELOCITY_X); -NODES[3021].Fix(VELOCITY_Y); -NODES[3021].Fix(VELOCITY_Z); -NODES[3028].Fix(VELOCITY_X); -NODES[3028].Fix(VELOCITY_Y); -NODES[3028].Fix(VELOCITY_Z); -NODES[3029].Fix(VELOCITY_X); -NODES[3029].Fix(VELOCITY_Y); -NODES[3029].Fix(VELOCITY_Z); -NODES[3030].Fix(VELOCITY_X); -NODES[3030].Fix(VELOCITY_Y); -NODES[3030].Fix(VELOCITY_Z); -NODES[3033].Fix(VELOCITY_X); -NODES[3033].Fix(VELOCITY_Y); -NODES[3033].Fix(VELOCITY_Z); -NODES[3034].Fix(VELOCITY_X); -NODES[3034].Fix(VELOCITY_Y); -NODES[3034].Fix(VELOCITY_Z); -NODES[3039].Fix(VELOCITY_X); -NODES[3039].Fix(VELOCITY_Y); -NODES[3039].Fix(VELOCITY_Z); -NODES[3045].Fix(VELOCITY_X); -NODES[3045].Fix(VELOCITY_Y); -NODES[3045].Fix(VELOCITY_Z); -NODES[3048].Fix(VELOCITY_X); -NODES[3048].Fix(VELOCITY_Y); -NODES[3048].Fix(VELOCITY_Z); -NODES[3051].Fix(VELOCITY_X); -NODES[3051].Fix(VELOCITY_Y); -NODES[3051].Fix(VELOCITY_Z); -NODES[3054].Fix(VELOCITY_X); -NODES[3054].Fix(VELOCITY_Y); -NODES[3054].Fix(VELOCITY_Z); -NODES[3055].Fix(VELOCITY_X); -NODES[3055].Fix(VELOCITY_Y); -NODES[3055].Fix(VELOCITY_Z); -NODES[3058].Fix(VELOCITY_X); -NODES[3058].Fix(VELOCITY_Y); -NODES[3058].Fix(VELOCITY_Z); -NODES[3059].Fix(VELOCITY_X); -NODES[3059].Fix(VELOCITY_Y); -NODES[3059].Fix(VELOCITY_Z); -NODES[3063].Fix(VELOCITY_X); -NODES[3063].Fix(VELOCITY_Y); -NODES[3063].Fix(VELOCITY_Z); -NODES[3079].Fix(VELOCITY_X); -NODES[3079].Fix(VELOCITY_Y); -NODES[3079].Fix(VELOCITY_Z); -NODES[3083].Fix(VELOCITY_X); -NODES[3083].Fix(VELOCITY_Y); -NODES[3083].Fix(VELOCITY_Z); -NODES[3085].Fix(VELOCITY_X); -NODES[3085].Fix(VELOCITY_Y); -NODES[3085].Fix(VELOCITY_Z); -NODES[3086].Fix(VELOCITY_X); -NODES[3086].Fix(VELOCITY_Y); -NODES[3086].Fix(VELOCITY_Z); -NODES[3091].Fix(VELOCITY_X); -NODES[3091].Fix(VELOCITY_Y); -NODES[3091].Fix(VELOCITY_Z); -NODES[3093].Fix(VELOCITY_X); -NODES[3093].Fix(VELOCITY_Y); -NODES[3093].Fix(VELOCITY_Z); -NODES[3097].Fix(VELOCITY_X); -NODES[3097].Fix(VELOCITY_Y); -NODES[3097].Fix(VELOCITY_Z); -NODES[3099].Fix(VELOCITY_X); -NODES[3099].Fix(VELOCITY_Y); -NODES[3099].Fix(VELOCITY_Z); -NODES[3100].Fix(VELOCITY_X); -NODES[3100].Fix(VELOCITY_Y); -NODES[3100].Fix(VELOCITY_Z); -NODES[3101].Fix(VELOCITY_X); -NODES[3101].Fix(VELOCITY_Y); -NODES[3101].Fix(VELOCITY_Z); -NODES[3105].Fix(VELOCITY_X); -NODES[3105].Fix(VELOCITY_Y); -NODES[3105].Fix(VELOCITY_Z); -NODES[3110].Fix(VELOCITY_X); -NODES[3110].Fix(VELOCITY_Y); -NODES[3110].Fix(VELOCITY_Z); -NODES[3119].Fix(VELOCITY_X); -NODES[3119].Fix(VELOCITY_Y); -NODES[3119].Fix(VELOCITY_Z); -NODES[3121].Fix(VELOCITY_X); -NODES[3121].Fix(VELOCITY_Y); -NODES[3121].Fix(VELOCITY_Z); -NODES[3131].Fix(VELOCITY_X); -NODES[3131].Fix(VELOCITY_Y); -NODES[3131].Fix(VELOCITY_Z); -NODES[3134].Fix(VELOCITY_X); -NODES[3134].Fix(VELOCITY_Y); -NODES[3134].Fix(VELOCITY_Z); -NODES[3153].Fix(VELOCITY_X); -NODES[3153].Fix(VELOCITY_Y); -NODES[3153].Fix(VELOCITY_Z); -NODES[3161].Fix(VELOCITY_X); -NODES[3161].Fix(VELOCITY_Y); -NODES[3161].Fix(VELOCITY_Z); -NODES[3165].Fix(VELOCITY_X); -NODES[3165].Fix(VELOCITY_Y); -NODES[3165].Fix(VELOCITY_Z); -NODES[3166].Fix(VELOCITY_X); -NODES[3166].Fix(VELOCITY_Y); -NODES[3166].Fix(VELOCITY_Z); -NODES[3167].Fix(VELOCITY_X); -NODES[3167].Fix(VELOCITY_Y); -NODES[3167].Fix(VELOCITY_Z); -NODES[3170].Fix(VELOCITY_X); -NODES[3170].Fix(VELOCITY_Y); -NODES[3170].Fix(VELOCITY_Z); -NODES[3171].Fix(VELOCITY_X); -NODES[3171].Fix(VELOCITY_Y); -NODES[3171].Fix(VELOCITY_Z); -NODES[3177].Fix(VELOCITY_X); -NODES[3177].Fix(VELOCITY_Y); -NODES[3177].Fix(VELOCITY_Z); -NODES[3194].Fix(VELOCITY_X); -NODES[3194].Fix(VELOCITY_Y); -NODES[3194].Fix(VELOCITY_Z); -NODES[3199].Fix(VELOCITY_X); -NODES[3199].Fix(VELOCITY_Y); -NODES[3199].Fix(VELOCITY_Z); -NODES[3217].Fix(VELOCITY_X); -NODES[3217].Fix(VELOCITY_Y); -NODES[3217].Fix(VELOCITY_Z); -NODES[3218].Fix(VELOCITY_X); -NODES[3218].Fix(VELOCITY_Y); -NODES[3218].Fix(VELOCITY_Z); -NODES[3220].Fix(VELOCITY_X); -NODES[3220].Fix(VELOCITY_Y); -NODES[3220].Fix(VELOCITY_Z); -NODES[3225].Fix(VELOCITY_X); -NODES[3225].Fix(VELOCITY_Y); -NODES[3225].Fix(VELOCITY_Z); -NODES[3228].Fix(VELOCITY_X); -NODES[3228].Fix(VELOCITY_Y); -NODES[3228].Fix(VELOCITY_Z); -NODES[3240].Fix(VELOCITY_X); -NODES[3240].Fix(VELOCITY_Y); -NODES[3240].Fix(VELOCITY_Z); -NODES[3241].Fix(VELOCITY_X); -NODES[3241].Fix(VELOCITY_Y); -NODES[3241].Fix(VELOCITY_Z); -NODES[3243].Fix(VELOCITY_X); -NODES[3243].Fix(VELOCITY_Y); -NODES[3243].Fix(VELOCITY_Z); -NODES[3251].Fix(VELOCITY_X); -NODES[3251].Fix(VELOCITY_Y); -NODES[3251].Fix(VELOCITY_Z); -NODES[3258].Fix(VELOCITY_X); -NODES[3258].Fix(VELOCITY_Y); -NODES[3258].Fix(VELOCITY_Z); -NODES[3264].Fix(VELOCITY_X); -NODES[3264].Fix(VELOCITY_Y); -NODES[3264].Fix(VELOCITY_Z); -NODES[3265].Fix(VELOCITY_X); -NODES[3265].Fix(VELOCITY_Y); -NODES[3265].Fix(VELOCITY_Z); -NODES[3268].Fix(VELOCITY_X); -NODES[3268].Fix(VELOCITY_Y); -NODES[3268].Fix(VELOCITY_Z); -NODES[3270].Fix(VELOCITY_X); -NODES[3270].Fix(VELOCITY_Y); -NODES[3270].Fix(VELOCITY_Z); -NODES[3272].Fix(VELOCITY_X); -NODES[3272].Fix(VELOCITY_Y); -NODES[3272].Fix(VELOCITY_Z); -NODES[3275].Fix(VELOCITY_X); -NODES[3275].Fix(VELOCITY_Y); -NODES[3275].Fix(VELOCITY_Z); -NODES[3276].Fix(VELOCITY_X); -NODES[3276].Fix(VELOCITY_Y); -NODES[3276].Fix(VELOCITY_Z); -NODES[3278].Fix(VELOCITY_X); -NODES[3278].Fix(VELOCITY_Y); -NODES[3278].Fix(VELOCITY_Z); -NODES[3279].Fix(VELOCITY_X); -NODES[3279].Fix(VELOCITY_Y); -NODES[3279].Fix(VELOCITY_Z); -NODES[3280].Fix(VELOCITY_X); -NODES[3280].Fix(VELOCITY_Y); -NODES[3280].Fix(VELOCITY_Z); -NODES[3282].Fix(VELOCITY_X); -NODES[3282].Fix(VELOCITY_Y); -NODES[3282].Fix(VELOCITY_Z); -NODES[3283].Fix(VELOCITY_X); -NODES[3283].Fix(VELOCITY_Y); -NODES[3283].Fix(VELOCITY_Z); -NODES[3287].Fix(VELOCITY_X); -NODES[3287].Fix(VELOCITY_Y); -NODES[3287].Fix(VELOCITY_Z); -NODES[3293].Fix(VELOCITY_X); -NODES[3293].Fix(VELOCITY_Y); -NODES[3293].Fix(VELOCITY_Z); -NODES[3294].Fix(VELOCITY_X); -NODES[3294].Fix(VELOCITY_Y); -NODES[3294].Fix(VELOCITY_Z); -NODES[3297].Fix(VELOCITY_X); -NODES[3297].Fix(VELOCITY_Y); -NODES[3297].Fix(VELOCITY_Z); -NODES[3301].Fix(VELOCITY_X); -NODES[3301].Fix(VELOCITY_Y); -NODES[3301].Fix(VELOCITY_Z); -NODES[3302].Fix(VELOCITY_X); -NODES[3302].Fix(VELOCITY_Y); -NODES[3302].Fix(VELOCITY_Z); -NODES[3303].Fix(VELOCITY_X); -NODES[3303].Fix(VELOCITY_Y); -NODES[3303].Fix(VELOCITY_Z); -NODES[3309].Fix(VELOCITY_X); -NODES[3309].Fix(VELOCITY_Y); -NODES[3309].Fix(VELOCITY_Z); -NODES[3311].Fix(VELOCITY_X); -NODES[3311].Fix(VELOCITY_Y); -NODES[3311].Fix(VELOCITY_Z); -NODES[3315].Fix(VELOCITY_X); -NODES[3315].Fix(VELOCITY_Y); -NODES[3315].Fix(VELOCITY_Z); -NODES[3322].Fix(VELOCITY_X); -NODES[3322].Fix(VELOCITY_Y); -NODES[3322].Fix(VELOCITY_Z); -NODES[3323].Fix(VELOCITY_X); -NODES[3323].Fix(VELOCITY_Y); -NODES[3323].Fix(VELOCITY_Z); -NODES[3324].Fix(VELOCITY_X); -NODES[3324].Fix(VELOCITY_Y); -NODES[3324].Fix(VELOCITY_Z); -NODES[3325].Fix(VELOCITY_X); -NODES[3325].Fix(VELOCITY_Y); -NODES[3325].Fix(VELOCITY_Z); -NODES[3341].Fix(VELOCITY_X); -NODES[3341].Fix(VELOCITY_Y); -NODES[3341].Fix(VELOCITY_Z); -NODES[3345].Fix(VELOCITY_X); -NODES[3345].Fix(VELOCITY_Y); -NODES[3345].Fix(VELOCITY_Z); -NODES[3346].Fix(VELOCITY_X); -NODES[3346].Fix(VELOCITY_Y); -NODES[3346].Fix(VELOCITY_Z); -NODES[3348].Fix(VELOCITY_X); -NODES[3348].Fix(VELOCITY_Y); -NODES[3348].Fix(VELOCITY_Z); -NODES[3350].Fix(VELOCITY_X); -NODES[3350].Fix(VELOCITY_Y); -NODES[3350].Fix(VELOCITY_Z); -NODES[3352].Fix(VELOCITY_X); -NODES[3352].Fix(VELOCITY_Y); -NODES[3352].Fix(VELOCITY_Z); -NODES[3354].Fix(VELOCITY_X); -NODES[3354].Fix(VELOCITY_Y); -NODES[3354].Fix(VELOCITY_Z); -NODES[3359].Fix(VELOCITY_X); -NODES[3359].Fix(VELOCITY_Y); -NODES[3359].Fix(VELOCITY_Z); -NODES[3366].Fix(VELOCITY_X); -NODES[3366].Fix(VELOCITY_Y); -NODES[3366].Fix(VELOCITY_Z); -NODES[3368].Fix(VELOCITY_X); -NODES[3368].Fix(VELOCITY_Y); -NODES[3368].Fix(VELOCITY_Z); -NODES[3372].Fix(VELOCITY_X); -NODES[3372].Fix(VELOCITY_Y); -NODES[3372].Fix(VELOCITY_Z); -NODES[3377].Fix(VELOCITY_X); -NODES[3377].Fix(VELOCITY_Y); -NODES[3377].Fix(VELOCITY_Z); -NODES[3380].Fix(VELOCITY_X); -NODES[3380].Fix(VELOCITY_Y); -NODES[3380].Fix(VELOCITY_Z); -NODES[3389].Fix(VELOCITY_X); -NODES[3389].Fix(VELOCITY_Y); -NODES[3389].Fix(VELOCITY_Z); -NODES[3390].Fix(VELOCITY_X); -NODES[3390].Fix(VELOCITY_Y); -NODES[3390].Fix(VELOCITY_Z); -NODES[3395].Fix(VELOCITY_X); -NODES[3395].Fix(VELOCITY_Y); -NODES[3395].Fix(VELOCITY_Z); -NODES[3399].Fix(VELOCITY_X); -NODES[3399].Fix(VELOCITY_Y); -NODES[3399].Fix(VELOCITY_Z); -NODES[3400].Fix(VELOCITY_X); -NODES[3400].Fix(VELOCITY_Y); -NODES[3400].Fix(VELOCITY_Z); -NODES[3405].Fix(VELOCITY_X); -NODES[3405].Fix(VELOCITY_Y); -NODES[3405].Fix(VELOCITY_Z); -NODES[3408].Fix(VELOCITY_X); -NODES[3408].Fix(VELOCITY_Y); -NODES[3408].Fix(VELOCITY_Z); -NODES[3412].Fix(VELOCITY_X); -NODES[3412].Fix(VELOCITY_Y); -NODES[3412].Fix(VELOCITY_Z); -NODES[3422].Fix(VELOCITY_X); -NODES[3422].Fix(VELOCITY_Y); -NODES[3422].Fix(VELOCITY_Z); -NODES[3436].Fix(VELOCITY_X); -NODES[3436].Fix(VELOCITY_Y); -NODES[3436].Fix(VELOCITY_Z); -NODES[3439].Fix(VELOCITY_X); -NODES[3439].Fix(VELOCITY_Y); -NODES[3439].Fix(VELOCITY_Z); -NODES[3449].Fix(VELOCITY_X); -NODES[3449].Fix(VELOCITY_Y); -NODES[3449].Fix(VELOCITY_Z); -NODES[3454].Fix(VELOCITY_X); -NODES[3454].Fix(VELOCITY_Y); -NODES[3454].Fix(VELOCITY_Z); -NODES[3455].Fix(VELOCITY_X); -NODES[3455].Fix(VELOCITY_Y); -NODES[3455].Fix(VELOCITY_Z); -NODES[3456].Fix(VELOCITY_X); -NODES[3456].Fix(VELOCITY_Y); -NODES[3456].Fix(VELOCITY_Z); -NODES[3461].Fix(VELOCITY_X); -NODES[3461].Fix(VELOCITY_Y); -NODES[3461].Fix(VELOCITY_Z); -NODES[3463].Fix(VELOCITY_X); -NODES[3463].Fix(VELOCITY_Y); -NODES[3463].Fix(VELOCITY_Z); -NODES[3465].Fix(VELOCITY_X); -NODES[3465].Fix(VELOCITY_Y); -NODES[3465].Fix(VELOCITY_Z); -NODES[3474].Fix(VELOCITY_X); -NODES[3474].Fix(VELOCITY_Y); -NODES[3474].Fix(VELOCITY_Z); -NODES[3475].Fix(VELOCITY_X); -NODES[3475].Fix(VELOCITY_Y); -NODES[3475].Fix(VELOCITY_Z); -NODES[3477].Fix(VELOCITY_X); -NODES[3477].Fix(VELOCITY_Y); -NODES[3477].Fix(VELOCITY_Z); -NODES[3481].Fix(VELOCITY_X); -NODES[3481].Fix(VELOCITY_Y); -NODES[3481].Fix(VELOCITY_Z); -NODES[3487].Fix(VELOCITY_X); -NODES[3487].Fix(VELOCITY_Y); -NODES[3487].Fix(VELOCITY_Z); -NODES[3493].Fix(VELOCITY_X); -NODES[3493].Fix(VELOCITY_Y); -NODES[3493].Fix(VELOCITY_Z); -NODES[3495].Fix(VELOCITY_X); -NODES[3495].Fix(VELOCITY_Y); -NODES[3495].Fix(VELOCITY_Z); -NODES[3496].Fix(VELOCITY_X); -NODES[3496].Fix(VELOCITY_Y); -NODES[3496].Fix(VELOCITY_Z); -NODES[3500].Fix(VELOCITY_X); -NODES[3500].Fix(VELOCITY_Y); -NODES[3500].Fix(VELOCITY_Z); -NODES[3521].Fix(VELOCITY_X); -NODES[3521].Fix(VELOCITY_Y); -NODES[3521].Fix(VELOCITY_Z); -NODES[3524].Fix(VELOCITY_X); -NODES[3524].Fix(VELOCITY_Y); -NODES[3524].Fix(VELOCITY_Z); -NODES[3529].Fix(VELOCITY_X); -NODES[3529].Fix(VELOCITY_Y); -NODES[3529].Fix(VELOCITY_Z); -NODES[3531].Fix(VELOCITY_X); -NODES[3531].Fix(VELOCITY_Y); -NODES[3531].Fix(VELOCITY_Z); -NODES[3532].Fix(VELOCITY_X); -NODES[3532].Fix(VELOCITY_Y); -NODES[3532].Fix(VELOCITY_Z); -NODES[3539].Fix(VELOCITY_X); -NODES[3539].Fix(VELOCITY_Y); -NODES[3539].Fix(VELOCITY_Z); -NODES[3541].Fix(VELOCITY_X); -NODES[3541].Fix(VELOCITY_Y); -NODES[3541].Fix(VELOCITY_Z); -NODES[3543].Fix(VELOCITY_X); -NODES[3543].Fix(VELOCITY_Y); -NODES[3543].Fix(VELOCITY_Z); -NODES[3558].Fix(VELOCITY_X); -NODES[3558].Fix(VELOCITY_Y); -NODES[3558].Fix(VELOCITY_Z); -NODES[3567].Fix(VELOCITY_X); -NODES[3567].Fix(VELOCITY_Y); -NODES[3567].Fix(VELOCITY_Z); -NODES[3571].Fix(VELOCITY_X); -NODES[3571].Fix(VELOCITY_Y); -NODES[3571].Fix(VELOCITY_Z); -NODES[3580].Fix(VELOCITY_X); -NODES[3580].Fix(VELOCITY_Y); -NODES[3580].Fix(VELOCITY_Z); -NODES[3585].Fix(VELOCITY_X); -NODES[3585].Fix(VELOCITY_Y); -NODES[3585].Fix(VELOCITY_Z); -NODES[3587].Fix(VELOCITY_X); -NODES[3587].Fix(VELOCITY_Y); -NODES[3587].Fix(VELOCITY_Z); -NODES[3615].Fix(VELOCITY_X); -NODES[3615].Fix(VELOCITY_Y); -NODES[3615].Fix(VELOCITY_Z); -NODES[3620].Fix(VELOCITY_X); -NODES[3620].Fix(VELOCITY_Y); -NODES[3620].Fix(VELOCITY_Z); -NODES[3621].Fix(VELOCITY_X); -NODES[3621].Fix(VELOCITY_Y); -NODES[3621].Fix(VELOCITY_Z); -NODES[3624].Fix(VELOCITY_X); -NODES[3624].Fix(VELOCITY_Y); -NODES[3624].Fix(VELOCITY_Z); -NODES[3626].Fix(VELOCITY_X); -NODES[3626].Fix(VELOCITY_Y); -NODES[3626].Fix(VELOCITY_Z); -NODES[3627].Fix(VELOCITY_X); -NODES[3627].Fix(VELOCITY_Y); -NODES[3627].Fix(VELOCITY_Z); -NODES[3628].Fix(VELOCITY_X); -NODES[3628].Fix(VELOCITY_Y); -NODES[3628].Fix(VELOCITY_Z); -NODES[3633].Fix(VELOCITY_X); -NODES[3633].Fix(VELOCITY_Y); -NODES[3633].Fix(VELOCITY_Z); -NODES[3645].Fix(VELOCITY_X); -NODES[3645].Fix(VELOCITY_Y); -NODES[3645].Fix(VELOCITY_Z); -NODES[3648].Fix(VELOCITY_X); -NODES[3648].Fix(VELOCITY_Y); -NODES[3648].Fix(VELOCITY_Z); -NODES[3650].Fix(VELOCITY_X); -NODES[3650].Fix(VELOCITY_Y); -NODES[3650].Fix(VELOCITY_Z); -NODES[3653].Fix(VELOCITY_X); -NODES[3653].Fix(VELOCITY_Y); -NODES[3653].Fix(VELOCITY_Z); -NODES[3657].Fix(VELOCITY_X); -NODES[3657].Fix(VELOCITY_Y); -NODES[3657].Fix(VELOCITY_Z); -NODES[3664].Fix(VELOCITY_X); -NODES[3664].Fix(VELOCITY_Y); -NODES[3664].Fix(VELOCITY_Z); -NODES[3674].Fix(VELOCITY_X); -NODES[3674].Fix(VELOCITY_Y); -NODES[3674].Fix(VELOCITY_Z); -NODES[3685].Fix(VELOCITY_X); -NODES[3685].Fix(VELOCITY_Y); -NODES[3685].Fix(VELOCITY_Z); -NODES[3689].Fix(VELOCITY_X); -NODES[3689].Fix(VELOCITY_Y); -NODES[3689].Fix(VELOCITY_Z); -NODES[3690].Fix(VELOCITY_X); -NODES[3690].Fix(VELOCITY_Y); -NODES[3690].Fix(VELOCITY_Z); -NODES[3693].Fix(VELOCITY_X); -NODES[3693].Fix(VELOCITY_Y); -NODES[3693].Fix(VELOCITY_Z); -NODES[3694].Fix(VELOCITY_X); -NODES[3694].Fix(VELOCITY_Y); -NODES[3694].Fix(VELOCITY_Z); -NODES[3695].Fix(VELOCITY_X); -NODES[3695].Fix(VELOCITY_Y); -NODES[3695].Fix(VELOCITY_Z); -NODES[3697].Fix(VELOCITY_X); -NODES[3697].Fix(VELOCITY_Y); -NODES[3697].Fix(VELOCITY_Z); -NODES[3701].Fix(VELOCITY_X); -NODES[3701].Fix(VELOCITY_Y); -NODES[3701].Fix(VELOCITY_Z); -NODES[3702].Fix(VELOCITY_X); -NODES[3702].Fix(VELOCITY_Y); -NODES[3702].Fix(VELOCITY_Z); -NODES[3703].Fix(VELOCITY_X); -NODES[3703].Fix(VELOCITY_Y); -NODES[3703].Fix(VELOCITY_Z); -NODES[3705].Fix(VELOCITY_X); -NODES[3705].Fix(VELOCITY_Y); -NODES[3705].Fix(VELOCITY_Z); -NODES[3706].Fix(VELOCITY_X); -NODES[3706].Fix(VELOCITY_Y); -NODES[3706].Fix(VELOCITY_Z); -NODES[3707].Fix(VELOCITY_X); -NODES[3707].Fix(VELOCITY_Y); -NODES[3707].Fix(VELOCITY_Z); -NODES[3709].Fix(VELOCITY_X); -NODES[3709].Fix(VELOCITY_Y); -NODES[3709].Fix(VELOCITY_Z); -NODES[3710].Fix(VELOCITY_X); -NODES[3710].Fix(VELOCITY_Y); -NODES[3710].Fix(VELOCITY_Z); -NODES[3711].Fix(VELOCITY_X); -NODES[3711].Fix(VELOCITY_Y); -NODES[3711].Fix(VELOCITY_Z); -NODES[3715].Fix(VELOCITY_X); -NODES[3715].Fix(VELOCITY_Y); -NODES[3715].Fix(VELOCITY_Z); -NODES[3718].Fix(VELOCITY_X); -NODES[3718].Fix(VELOCITY_Y); -NODES[3718].Fix(VELOCITY_Z); -NODES[3722].Fix(VELOCITY_X); -NODES[3722].Fix(VELOCITY_Y); -NODES[3722].Fix(VELOCITY_Z); -NODES[3724].Fix(VELOCITY_X); -NODES[3724].Fix(VELOCITY_Y); -NODES[3724].Fix(VELOCITY_Z); -NODES[3729].Fix(VELOCITY_X); -NODES[3729].Fix(VELOCITY_Y); -NODES[3729].Fix(VELOCITY_Z); -NODES[3732].Fix(VELOCITY_X); -NODES[3732].Fix(VELOCITY_Y); -NODES[3732].Fix(VELOCITY_Z); -NODES[3733].Fix(VELOCITY_X); -NODES[3733].Fix(VELOCITY_Y); -NODES[3733].Fix(VELOCITY_Z); -NODES[3735].Fix(VELOCITY_X); -NODES[3735].Fix(VELOCITY_Y); -NODES[3735].Fix(VELOCITY_Z); -NODES[3736].Fix(VELOCITY_X); -NODES[3736].Fix(VELOCITY_Y); -NODES[3736].Fix(VELOCITY_Z); -NODES[3742].Fix(VELOCITY_X); -NODES[3742].Fix(VELOCITY_Y); -NODES[3742].Fix(VELOCITY_Z); -NODES[3749].Fix(VELOCITY_X); -NODES[3749].Fix(VELOCITY_Y); -NODES[3749].Fix(VELOCITY_Z); -NODES[3750].Fix(VELOCITY_X); -NODES[3750].Fix(VELOCITY_Y); -NODES[3750].Fix(VELOCITY_Z); -NODES[3753].Fix(VELOCITY_X); -NODES[3753].Fix(VELOCITY_Y); -NODES[3753].Fix(VELOCITY_Z); -NODES[3757].Fix(VELOCITY_X); -NODES[3757].Fix(VELOCITY_Y); -NODES[3757].Fix(VELOCITY_Z); -NODES[3758].Fix(VELOCITY_X); -NODES[3758].Fix(VELOCITY_Y); -NODES[3758].Fix(VELOCITY_Z); -NODES[3759].Fix(VELOCITY_X); -NODES[3759].Fix(VELOCITY_Y); -NODES[3759].Fix(VELOCITY_Z); -NODES[3761].Fix(VELOCITY_X); -NODES[3761].Fix(VELOCITY_Y); -NODES[3761].Fix(VELOCITY_Z); -NODES[3775].Fix(VELOCITY_X); -NODES[3775].Fix(VELOCITY_Y); -NODES[3775].Fix(VELOCITY_Z); -NODES[3790].Fix(VELOCITY_X); -NODES[3790].Fix(VELOCITY_Y); -NODES[3790].Fix(VELOCITY_Z); -NODES[3791].Fix(VELOCITY_X); -NODES[3791].Fix(VELOCITY_Y); -NODES[3791].Fix(VELOCITY_Z); -NODES[3792].Fix(VELOCITY_X); -NODES[3792].Fix(VELOCITY_Y); -NODES[3792].Fix(VELOCITY_Z); -NODES[3803].Fix(VELOCITY_X); -NODES[3803].Fix(VELOCITY_Y); -NODES[3803].Fix(VELOCITY_Z); -NODES[3804].Fix(VELOCITY_X); -NODES[3804].Fix(VELOCITY_Y); -NODES[3804].Fix(VELOCITY_Z); -NODES[3806].Fix(VELOCITY_X); -NODES[3806].Fix(VELOCITY_Y); -NODES[3806].Fix(VELOCITY_Z); -NODES[3821].Fix(VELOCITY_X); -NODES[3821].Fix(VELOCITY_Y); -NODES[3821].Fix(VELOCITY_Z); -NODES[3824].Fix(VELOCITY_X); -NODES[3824].Fix(VELOCITY_Y); -NODES[3824].Fix(VELOCITY_Z); -NODES[3830].Fix(VELOCITY_X); -NODES[3830].Fix(VELOCITY_Y); -NODES[3830].Fix(VELOCITY_Z); -NODES[3833].Fix(VELOCITY_X); -NODES[3833].Fix(VELOCITY_Y); -NODES[3833].Fix(VELOCITY_Z); -NODES[3836].Fix(VELOCITY_X); -NODES[3836].Fix(VELOCITY_Y); -NODES[3836].Fix(VELOCITY_Z); -NODES[3841].Fix(VELOCITY_X); -NODES[3841].Fix(VELOCITY_Y); -NODES[3841].Fix(VELOCITY_Z); -NODES[3849].Fix(VELOCITY_X); -NODES[3849].Fix(VELOCITY_Y); -NODES[3849].Fix(VELOCITY_Z); -NODES[3850].Fix(VELOCITY_X); -NODES[3850].Fix(VELOCITY_Y); -NODES[3850].Fix(VELOCITY_Z); -NODES[3858].Fix(VELOCITY_X); -NODES[3858].Fix(VELOCITY_Y); -NODES[3858].Fix(VELOCITY_Z); -NODES[3859].Fix(VELOCITY_X); -NODES[3859].Fix(VELOCITY_Y); -NODES[3859].Fix(VELOCITY_Z); -NODES[3865].Fix(VELOCITY_X); -NODES[3865].Fix(VELOCITY_Y); -NODES[3865].Fix(VELOCITY_Z); -NODES[3870].Fix(VELOCITY_X); -NODES[3870].Fix(VELOCITY_Y); -NODES[3870].Fix(VELOCITY_Z); -NODES[3872].Fix(VELOCITY_X); -NODES[3872].Fix(VELOCITY_Y); -NODES[3872].Fix(VELOCITY_Z); -NODES[3887].Fix(VELOCITY_X); -NODES[3887].Fix(VELOCITY_Y); -NODES[3887].Fix(VELOCITY_Z); -NODES[3889].Fix(VELOCITY_X); -NODES[3889].Fix(VELOCITY_Y); -NODES[3889].Fix(VELOCITY_Z); -NODES[3891].Fix(VELOCITY_X); -NODES[3891].Fix(VELOCITY_Y); -NODES[3891].Fix(VELOCITY_Z); -NODES[3896].Fix(VELOCITY_X); -NODES[3896].Fix(VELOCITY_Y); -NODES[3896].Fix(VELOCITY_Z); -NODES[3901].Fix(VELOCITY_X); -NODES[3901].Fix(VELOCITY_Y); -NODES[3901].Fix(VELOCITY_Z); -NODES[3915].Fix(VELOCITY_X); -NODES[3915].Fix(VELOCITY_Y); -NODES[3915].Fix(VELOCITY_Z); -NODES[3920].Fix(VELOCITY_X); -NODES[3920].Fix(VELOCITY_Y); -NODES[3920].Fix(VELOCITY_Z); -NODES[3921].Fix(VELOCITY_X); -NODES[3921].Fix(VELOCITY_Y); -NODES[3921].Fix(VELOCITY_Z); -NODES[3923].Fix(VELOCITY_X); -NODES[3923].Fix(VELOCITY_Y); -NODES[3923].Fix(VELOCITY_Z); -NODES[3929].Fix(VELOCITY_X); -NODES[3929].Fix(VELOCITY_Y); -NODES[3929].Fix(VELOCITY_Z); -NODES[3931].Fix(VELOCITY_X); -NODES[3931].Fix(VELOCITY_Y); -NODES[3931].Fix(VELOCITY_Z); -NODES[3937].Fix(VELOCITY_X); -NODES[3937].Fix(VELOCITY_Y); -NODES[3937].Fix(VELOCITY_Z); -NODES[3938].Fix(VELOCITY_X); -NODES[3938].Fix(VELOCITY_Y); -NODES[3938].Fix(VELOCITY_Z); -NODES[3953].Fix(VELOCITY_X); -NODES[3953].Fix(VELOCITY_Y); -NODES[3953].Fix(VELOCITY_Z); -NODES[3963].Fix(VELOCITY_X); -NODES[3963].Fix(VELOCITY_Y); -NODES[3963].Fix(VELOCITY_Z); -NODES[3968].Fix(VELOCITY_X); -NODES[3968].Fix(VELOCITY_Y); -NODES[3968].Fix(VELOCITY_Z); -NODES[3969].Fix(VELOCITY_X); -NODES[3969].Fix(VELOCITY_Y); -NODES[3969].Fix(VELOCITY_Z); -NODES[3972].Fix(VELOCITY_X); -NODES[3972].Fix(VELOCITY_Y); -NODES[3972].Fix(VELOCITY_Z); -NODES[3975].Fix(VELOCITY_X); -NODES[3975].Fix(VELOCITY_Y); -NODES[3975].Fix(VELOCITY_Z); -NODES[3981].Fix(VELOCITY_X); -NODES[3981].Fix(VELOCITY_Y); -NODES[3981].Fix(VELOCITY_Z); -NODES[3987].Fix(VELOCITY_X); -NODES[3987].Fix(VELOCITY_Y); -NODES[3987].Fix(VELOCITY_Z); -NODES[3997].Fix(VELOCITY_X); -NODES[3997].Fix(VELOCITY_Y); -NODES[3997].Fix(VELOCITY_Z); -NODES[3998].Fix(VELOCITY_X); -NODES[3998].Fix(VELOCITY_Y); -NODES[3998].Fix(VELOCITY_Z); -NODES[4002].Fix(VELOCITY_X); -NODES[4002].Fix(VELOCITY_Y); -NODES[4002].Fix(VELOCITY_Z); -NODES[4006].Fix(VELOCITY_X); -NODES[4006].Fix(VELOCITY_Y); -NODES[4006].Fix(VELOCITY_Z); -NODES[4018].Fix(VELOCITY_X); -NODES[4018].Fix(VELOCITY_Y); -NODES[4018].Fix(VELOCITY_Z); -NODES[4020].Fix(VELOCITY_X); -NODES[4020].Fix(VELOCITY_Y); -NODES[4020].Fix(VELOCITY_Z); -NODES[4021].Fix(VELOCITY_X); -NODES[4021].Fix(VELOCITY_Y); -NODES[4021].Fix(VELOCITY_Z); -NODES[4024].Fix(VELOCITY_X); -NODES[4024].Fix(VELOCITY_Y); -NODES[4024].Fix(VELOCITY_Z); -NODES[4038].Fix(VELOCITY_X); -NODES[4038].Fix(VELOCITY_Y); -NODES[4038].Fix(VELOCITY_Z); -NODES[4042].Fix(VELOCITY_X); -NODES[4042].Fix(VELOCITY_Y); -NODES[4042].Fix(VELOCITY_Z); -NODES[4046].Fix(VELOCITY_X); -NODES[4046].Fix(VELOCITY_Y); -NODES[4046].Fix(VELOCITY_Z); -NODES[4050].Fix(VELOCITY_X); -NODES[4050].Fix(VELOCITY_Y); -NODES[4050].Fix(VELOCITY_Z); -NODES[4065].Fix(VELOCITY_X); -NODES[4065].Fix(VELOCITY_Y); -NODES[4065].Fix(VELOCITY_Z); -NODES[4073].Fix(VELOCITY_X); -NODES[4073].Fix(VELOCITY_Y); -NODES[4073].Fix(VELOCITY_Z); -NODES[4076].Fix(VELOCITY_X); -NODES[4076].Fix(VELOCITY_Y); -NODES[4076].Fix(VELOCITY_Z); -NODES[4079].Fix(VELOCITY_X); -NODES[4079].Fix(VELOCITY_Y); -NODES[4079].Fix(VELOCITY_Z); -NODES[4082].Fix(VELOCITY_X); -NODES[4082].Fix(VELOCITY_Y); -NODES[4082].Fix(VELOCITY_Z); -NODES[4085].Fix(VELOCITY_X); -NODES[4085].Fix(VELOCITY_Y); -NODES[4085].Fix(VELOCITY_Z); -NODES[4093].Fix(VELOCITY_X); -NODES[4093].Fix(VELOCITY_Y); -NODES[4093].Fix(VELOCITY_Z); -NODES[4095].Fix(VELOCITY_X); -NODES[4095].Fix(VELOCITY_Y); -NODES[4095].Fix(VELOCITY_Z); -NODES[4096].Fix(VELOCITY_X); -NODES[4096].Fix(VELOCITY_Y); -NODES[4096].Fix(VELOCITY_Z); -NODES[4099].Fix(VELOCITY_X); -NODES[4099].Fix(VELOCITY_Y); -NODES[4099].Fix(VELOCITY_Z); -NODES[4108].Fix(VELOCITY_X); -NODES[4108].Fix(VELOCITY_Y); -NODES[4108].Fix(VELOCITY_Z); -NODES[4114].Fix(VELOCITY_X); -NODES[4114].Fix(VELOCITY_Y); -NODES[4114].Fix(VELOCITY_Z); -NODES[4115].Fix(VELOCITY_X); -NODES[4115].Fix(VELOCITY_Y); -NODES[4115].Fix(VELOCITY_Z); -NODES[4123].Fix(VELOCITY_X); -NODES[4123].Fix(VELOCITY_Y); -NODES[4123].Fix(VELOCITY_Z); -NODES[4124].Fix(VELOCITY_X); -NODES[4124].Fix(VELOCITY_Y); -NODES[4124].Fix(VELOCITY_Z); -NODES[4138].Fix(VELOCITY_X); -NODES[4138].Fix(VELOCITY_Y); -NODES[4138].Fix(VELOCITY_Z); -NODES[4148].Fix(VELOCITY_X); -NODES[4148].Fix(VELOCITY_Y); -NODES[4148].Fix(VELOCITY_Z); -NODES[4149].Fix(VELOCITY_X); -NODES[4149].Fix(VELOCITY_Y); -NODES[4149].Fix(VELOCITY_Z); -NODES[4151].Fix(VELOCITY_X); -NODES[4151].Fix(VELOCITY_Y); -NODES[4151].Fix(VELOCITY_Z); -NODES[4152].Fix(VELOCITY_X); -NODES[4152].Fix(VELOCITY_Y); -NODES[4152].Fix(VELOCITY_Z); -NODES[4157].Fix(VELOCITY_X); -NODES[4157].Fix(VELOCITY_Y); -NODES[4157].Fix(VELOCITY_Z); -NODES[4158].Fix(VELOCITY_X); -NODES[4158].Fix(VELOCITY_Y); -NODES[4158].Fix(VELOCITY_Z); -NODES[4161].Fix(VELOCITY_X); -NODES[4161].Fix(VELOCITY_Y); -NODES[4161].Fix(VELOCITY_Z); -NODES[4163].Fix(VELOCITY_X); -NODES[4163].Fix(VELOCITY_Y); -NODES[4163].Fix(VELOCITY_Z); -NODES[4167].Fix(VELOCITY_X); -NODES[4167].Fix(VELOCITY_Y); -NODES[4167].Fix(VELOCITY_Z); -NODES[4168].Fix(VELOCITY_X); -NODES[4168].Fix(VELOCITY_Y); -NODES[4168].Fix(VELOCITY_Z); -NODES[4172].Fix(VELOCITY_X); -NODES[4172].Fix(VELOCITY_Y); -NODES[4172].Fix(VELOCITY_Z); -NODES[4174].Fix(VELOCITY_X); -NODES[4174].Fix(VELOCITY_Y); -NODES[4174].Fix(VELOCITY_Z); -NODES[4178].Fix(VELOCITY_X); -NODES[4178].Fix(VELOCITY_Y); -NODES[4178].Fix(VELOCITY_Z); -NODES[4179].Fix(VELOCITY_X); -NODES[4179].Fix(VELOCITY_Y); -NODES[4179].Fix(VELOCITY_Z); -NODES[4187].Fix(VELOCITY_X); -NODES[4187].Fix(VELOCITY_Y); -NODES[4187].Fix(VELOCITY_Z); -NODES[4188].Fix(VELOCITY_X); -NODES[4188].Fix(VELOCITY_Y); -NODES[4188].Fix(VELOCITY_Z); -NODES[4191].Fix(VELOCITY_X); -NODES[4191].Fix(VELOCITY_Y); -NODES[4191].Fix(VELOCITY_Z); -NODES[4192].Fix(VELOCITY_X); -NODES[4192].Fix(VELOCITY_Y); -NODES[4192].Fix(VELOCITY_Z); -NODES[4197].Fix(VELOCITY_X); -NODES[4197].Fix(VELOCITY_Y); -NODES[4197].Fix(VELOCITY_Z); -NODES[4200].Fix(VELOCITY_X); -NODES[4200].Fix(VELOCITY_Y); -NODES[4200].Fix(VELOCITY_Z); -NODES[4201].Fix(VELOCITY_X); -NODES[4201].Fix(VELOCITY_Y); -NODES[4201].Fix(VELOCITY_Z); -NODES[4211].Fix(VELOCITY_X); -NODES[4211].Fix(VELOCITY_Y); -NODES[4211].Fix(VELOCITY_Z); -NODES[4227].Fix(VELOCITY_X); -NODES[4227].Fix(VELOCITY_Y); -NODES[4227].Fix(VELOCITY_Z); -NODES[4235].Fix(VELOCITY_X); -NODES[4235].Fix(VELOCITY_Y); -NODES[4235].Fix(VELOCITY_Z); -NODES[4236].Fix(VELOCITY_X); -NODES[4236].Fix(VELOCITY_Y); -NODES[4236].Fix(VELOCITY_Z); -NODES[4245].Fix(VELOCITY_X); -NODES[4245].Fix(VELOCITY_Y); -NODES[4245].Fix(VELOCITY_Z); -NODES[4246].Fix(VELOCITY_X); -NODES[4246].Fix(VELOCITY_Y); -NODES[4246].Fix(VELOCITY_Z); -NODES[4247].Fix(VELOCITY_X); -NODES[4247].Fix(VELOCITY_Y); -NODES[4247].Fix(VELOCITY_Z); -NODES[4252].Fix(VELOCITY_X); -NODES[4252].Fix(VELOCITY_Y); -NODES[4252].Fix(VELOCITY_Z); -NODES[4256].Fix(VELOCITY_X); -NODES[4256].Fix(VELOCITY_Y); -NODES[4256].Fix(VELOCITY_Z); -NODES[4257].Fix(VELOCITY_X); -NODES[4257].Fix(VELOCITY_Y); -NODES[4257].Fix(VELOCITY_Z); -NODES[4270].Fix(VELOCITY_X); -NODES[4270].Fix(VELOCITY_Y); -NODES[4270].Fix(VELOCITY_Z); -NODES[4277].Fix(VELOCITY_X); -NODES[4277].Fix(VELOCITY_Y); -NODES[4277].Fix(VELOCITY_Z); -NODES[4283].Fix(VELOCITY_X); -NODES[4283].Fix(VELOCITY_Y); -NODES[4283].Fix(VELOCITY_Z); -NODES[4298].Fix(VELOCITY_X); -NODES[4298].Fix(VELOCITY_Y); -NODES[4298].Fix(VELOCITY_Z); -NODES[4299].Fix(VELOCITY_X); -NODES[4299].Fix(VELOCITY_Y); -NODES[4299].Fix(VELOCITY_Z); -NODES[4309].Fix(VELOCITY_X); -NODES[4309].Fix(VELOCITY_Y); -NODES[4309].Fix(VELOCITY_Z); -NODES[4310].Fix(VELOCITY_X); -NODES[4310].Fix(VELOCITY_Y); -NODES[4310].Fix(VELOCITY_Z); -NODES[4313].Fix(VELOCITY_X); -NODES[4313].Fix(VELOCITY_Y); -NODES[4313].Fix(VELOCITY_Z); -NODES[4316].Fix(VELOCITY_X); -NODES[4316].Fix(VELOCITY_Y); -NODES[4316].Fix(VELOCITY_Z); -NODES[4329].Fix(VELOCITY_X); -NODES[4329].Fix(VELOCITY_Y); -NODES[4329].Fix(VELOCITY_Z); -NODES[4332].Fix(VELOCITY_X); -NODES[4332].Fix(VELOCITY_Y); -NODES[4332].Fix(VELOCITY_Z); -NODES[4333].Fix(VELOCITY_X); -NODES[4333].Fix(VELOCITY_Y); -NODES[4333].Fix(VELOCITY_Z); -NODES[4336].Fix(VELOCITY_X); -NODES[4336].Fix(VELOCITY_Y); -NODES[4336].Fix(VELOCITY_Z); -NODES[4342].Fix(VELOCITY_X); -NODES[4342].Fix(VELOCITY_Y); -NODES[4342].Fix(VELOCITY_Z); -NODES[4346].Fix(VELOCITY_X); -NODES[4346].Fix(VELOCITY_Y); -NODES[4346].Fix(VELOCITY_Z); -NODES[4347].Fix(VELOCITY_X); -NODES[4347].Fix(VELOCITY_Y); -NODES[4347].Fix(VELOCITY_Z); -NODES[4358].Fix(VELOCITY_X); -NODES[4358].Fix(VELOCITY_Y); -NODES[4358].Fix(VELOCITY_Z); -NODES[4366].Fix(VELOCITY_X); -NODES[4366].Fix(VELOCITY_Y); -NODES[4366].Fix(VELOCITY_Z); -NODES[4373].Fix(VELOCITY_X); -NODES[4373].Fix(VELOCITY_Y); -NODES[4373].Fix(VELOCITY_Z); -NODES[4374].Fix(VELOCITY_X); -NODES[4374].Fix(VELOCITY_Y); -NODES[4374].Fix(VELOCITY_Z); -NODES[4382].Fix(VELOCITY_X); -NODES[4382].Fix(VELOCITY_Y); -NODES[4382].Fix(VELOCITY_Z); -NODES[4394].Fix(VELOCITY_X); -NODES[4394].Fix(VELOCITY_Y); -NODES[4394].Fix(VELOCITY_Z); -NODES[4396].Fix(VELOCITY_X); -NODES[4396].Fix(VELOCITY_Y); -NODES[4396].Fix(VELOCITY_Z); -NODES[4397].Fix(VELOCITY_X); -NODES[4397].Fix(VELOCITY_Y); -NODES[4397].Fix(VELOCITY_Z); -NODES[4398].Fix(VELOCITY_X); -NODES[4398].Fix(VELOCITY_Y); -NODES[4398].Fix(VELOCITY_Z); -NODES[4400].Fix(VELOCITY_X); -NODES[4400].Fix(VELOCITY_Y); -NODES[4400].Fix(VELOCITY_Z); -NODES[4401].Fix(VELOCITY_X); -NODES[4401].Fix(VELOCITY_Y); -NODES[4401].Fix(VELOCITY_Z); -NODES[4402].Fix(VELOCITY_X); -NODES[4402].Fix(VELOCITY_Y); -NODES[4402].Fix(VELOCITY_Z); -NODES[4412].Fix(VELOCITY_X); -NODES[4412].Fix(VELOCITY_Y); -NODES[4412].Fix(VELOCITY_Z); -NODES[4435].Fix(VELOCITY_X); -NODES[4435].Fix(VELOCITY_Y); -NODES[4435].Fix(VELOCITY_Z); -NODES[4438].Fix(VELOCITY_X); -NODES[4438].Fix(VELOCITY_Y); -NODES[4438].Fix(VELOCITY_Z); -NODES[4455].Fix(VELOCITY_X); -NODES[4455].Fix(VELOCITY_Y); -NODES[4455].Fix(VELOCITY_Z); -NODES[4456].Fix(VELOCITY_X); -NODES[4456].Fix(VELOCITY_Y); -NODES[4456].Fix(VELOCITY_Z); -NODES[4457].Fix(VELOCITY_X); -NODES[4457].Fix(VELOCITY_Y); -NODES[4457].Fix(VELOCITY_Z); -NODES[4458].Fix(VELOCITY_X); -NODES[4458].Fix(VELOCITY_Y); -NODES[4458].Fix(VELOCITY_Z); -NODES[4470].Fix(VELOCITY_X); -NODES[4470].Fix(VELOCITY_Y); -NODES[4470].Fix(VELOCITY_Z); -NODES[4484].Fix(VELOCITY_X); -NODES[4484].Fix(VELOCITY_Y); -NODES[4484].Fix(VELOCITY_Z); -NODES[4498].Fix(VELOCITY_X); -NODES[4498].Fix(VELOCITY_Y); -NODES[4498].Fix(VELOCITY_Z); -NODES[4505].Fix(VELOCITY_X); -NODES[4505].Fix(VELOCITY_Y); -NODES[4505].Fix(VELOCITY_Z); -NODES[4513].Fix(VELOCITY_X); -NODES[4513].Fix(VELOCITY_Y); -NODES[4513].Fix(VELOCITY_Z); -NODES[4515].Fix(VELOCITY_X); -NODES[4515].Fix(VELOCITY_Y); -NODES[4515].Fix(VELOCITY_Z); -NODES[4530].Fix(VELOCITY_X); -NODES[4530].Fix(VELOCITY_Y); -NODES[4530].Fix(VELOCITY_Z); -NODES[4535].Fix(VELOCITY_X); -NODES[4535].Fix(VELOCITY_Y); -NODES[4535].Fix(VELOCITY_Z); -NODES[4547].Fix(VELOCITY_X); -NODES[4547].Fix(VELOCITY_Y); -NODES[4547].Fix(VELOCITY_Z); -NODES[4549].Fix(VELOCITY_X); -NODES[4549].Fix(VELOCITY_Y); -NODES[4549].Fix(VELOCITY_Z); -NODES[4551].Fix(VELOCITY_X); -NODES[4551].Fix(VELOCITY_Y); -NODES[4551].Fix(VELOCITY_Z); -NODES[4553].Fix(VELOCITY_X); -NODES[4553].Fix(VELOCITY_Y); -NODES[4553].Fix(VELOCITY_Z); -NODES[4554].Fix(VELOCITY_X); -NODES[4554].Fix(VELOCITY_Y); -NODES[4554].Fix(VELOCITY_Z); -NODES[4563].Fix(VELOCITY_X); -NODES[4563].Fix(VELOCITY_Y); -NODES[4563].Fix(VELOCITY_Z); -NODES[4575].Fix(VELOCITY_X); -NODES[4575].Fix(VELOCITY_Y); -NODES[4575].Fix(VELOCITY_Z); -NODES[4576].Fix(VELOCITY_X); -NODES[4576].Fix(VELOCITY_Y); -NODES[4576].Fix(VELOCITY_Z); -NODES[4581].Fix(VELOCITY_X); -NODES[4581].Fix(VELOCITY_Y); -NODES[4581].Fix(VELOCITY_Z); -NODES[4582].Fix(VELOCITY_X); -NODES[4582].Fix(VELOCITY_Y); -NODES[4582].Fix(VELOCITY_Z); -NODES[4586].Fix(VELOCITY_X); -NODES[4586].Fix(VELOCITY_Y); -NODES[4586].Fix(VELOCITY_Z); -NODES[4588].Fix(VELOCITY_X); -NODES[4588].Fix(VELOCITY_Y); -NODES[4588].Fix(VELOCITY_Z); -NODES[4594].Fix(VELOCITY_X); -NODES[4594].Fix(VELOCITY_Y); -NODES[4594].Fix(VELOCITY_Z); -NODES[4598].Fix(VELOCITY_X); -NODES[4598].Fix(VELOCITY_Y); -NODES[4598].Fix(VELOCITY_Z); -NODES[4599].Fix(VELOCITY_X); -NODES[4599].Fix(VELOCITY_Y); -NODES[4599].Fix(VELOCITY_Z); -NODES[4605].Fix(VELOCITY_X); -NODES[4605].Fix(VELOCITY_Y); -NODES[4605].Fix(VELOCITY_Z); -NODES[4607].Fix(VELOCITY_X); -NODES[4607].Fix(VELOCITY_Y); -NODES[4607].Fix(VELOCITY_Z); -NODES[4611].Fix(VELOCITY_X); -NODES[4611].Fix(VELOCITY_Y); -NODES[4611].Fix(VELOCITY_Z); -NODES[4616].Fix(VELOCITY_X); -NODES[4616].Fix(VELOCITY_Y); -NODES[4616].Fix(VELOCITY_Z); -NODES[4627].Fix(VELOCITY_X); -NODES[4627].Fix(VELOCITY_Y); -NODES[4627].Fix(VELOCITY_Z); -NODES[4632].Fix(VELOCITY_X); -NODES[4632].Fix(VELOCITY_Y); -NODES[4632].Fix(VELOCITY_Z); -NODES[4642].Fix(VELOCITY_X); -NODES[4642].Fix(VELOCITY_Y); -NODES[4642].Fix(VELOCITY_Z); -NODES[4647].Fix(VELOCITY_X); -NODES[4647].Fix(VELOCITY_Y); -NODES[4647].Fix(VELOCITY_Z); -NODES[4648].Fix(VELOCITY_X); -NODES[4648].Fix(VELOCITY_Y); -NODES[4648].Fix(VELOCITY_Z); -NODES[4652].Fix(VELOCITY_X); -NODES[4652].Fix(VELOCITY_Y); -NODES[4652].Fix(VELOCITY_Z); -NODES[4665].Fix(VELOCITY_X); -NODES[4665].Fix(VELOCITY_Y); -NODES[4665].Fix(VELOCITY_Z); -NODES[4670].Fix(VELOCITY_X); -NODES[4670].Fix(VELOCITY_Y); -NODES[4670].Fix(VELOCITY_Z); -NODES[4671].Fix(VELOCITY_X); -NODES[4671].Fix(VELOCITY_Y); -NODES[4671].Fix(VELOCITY_Z); -NODES[4674].Fix(VELOCITY_X); -NODES[4674].Fix(VELOCITY_Y); -NODES[4674].Fix(VELOCITY_Z); -NODES[4675].Fix(VELOCITY_X); -NODES[4675].Fix(VELOCITY_Y); -NODES[4675].Fix(VELOCITY_Z); -NODES[4678].Fix(VELOCITY_X); -NODES[4678].Fix(VELOCITY_Y); -NODES[4678].Fix(VELOCITY_Z); -NODES[4686].Fix(VELOCITY_X); -NODES[4686].Fix(VELOCITY_Y); -NODES[4686].Fix(VELOCITY_Z); -NODES[4687].Fix(VELOCITY_X); -NODES[4687].Fix(VELOCITY_Y); -NODES[4687].Fix(VELOCITY_Z); -NODES[4696].Fix(VELOCITY_X); -NODES[4696].Fix(VELOCITY_Y); -NODES[4696].Fix(VELOCITY_Z); -NODES[4697].Fix(VELOCITY_X); -NODES[4697].Fix(VELOCITY_Y); -NODES[4697].Fix(VELOCITY_Z); -NODES[4702].Fix(VELOCITY_X); -NODES[4702].Fix(VELOCITY_Y); -NODES[4702].Fix(VELOCITY_Z); -NODES[4703].Fix(VELOCITY_X); -NODES[4703].Fix(VELOCITY_Y); -NODES[4703].Fix(VELOCITY_Z); -NODES[4704].Fix(VELOCITY_X); -NODES[4704].Fix(VELOCITY_Y); -NODES[4704].Fix(VELOCITY_Z); -NODES[4706].Fix(VELOCITY_X); -NODES[4706].Fix(VELOCITY_Y); -NODES[4706].Fix(VELOCITY_Z); -NODES[4707].Fix(VELOCITY_X); -NODES[4707].Fix(VELOCITY_Y); -NODES[4707].Fix(VELOCITY_Z); -NODES[4716].Fix(VELOCITY_X); -NODES[4716].Fix(VELOCITY_Y); -NODES[4716].Fix(VELOCITY_Z); -NODES[4728].Fix(VELOCITY_X); -NODES[4728].Fix(VELOCITY_Y); -NODES[4728].Fix(VELOCITY_Z); -NODES[4729].Fix(VELOCITY_X); -NODES[4729].Fix(VELOCITY_Y); -NODES[4729].Fix(VELOCITY_Z); -NODES[4732].Fix(VELOCITY_X); -NODES[4732].Fix(VELOCITY_Y); -NODES[4732].Fix(VELOCITY_Z); -NODES[4735].Fix(VELOCITY_X); -NODES[4735].Fix(VELOCITY_Y); -NODES[4735].Fix(VELOCITY_Z); -NODES[4736].Fix(VELOCITY_X); -NODES[4736].Fix(VELOCITY_Y); -NODES[4736].Fix(VELOCITY_Z); -NODES[4748].Fix(VELOCITY_X); -NODES[4748].Fix(VELOCITY_Y); -NODES[4748].Fix(VELOCITY_Z); -NODES[4749].Fix(VELOCITY_X); -NODES[4749].Fix(VELOCITY_Y); -NODES[4749].Fix(VELOCITY_Z); -NODES[4760].Fix(VELOCITY_X); -NODES[4760].Fix(VELOCITY_Y); -NODES[4760].Fix(VELOCITY_Z); -NODES[4764].Fix(VELOCITY_X); -NODES[4764].Fix(VELOCITY_Y); -NODES[4764].Fix(VELOCITY_Z); -NODES[4770].Fix(VELOCITY_X); -NODES[4770].Fix(VELOCITY_Y); -NODES[4770].Fix(VELOCITY_Z); -NODES[4773].Fix(VELOCITY_X); -NODES[4773].Fix(VELOCITY_Y); -NODES[4773].Fix(VELOCITY_Z); -NODES[4781].Fix(VELOCITY_X); -NODES[4781].Fix(VELOCITY_Y); -NODES[4781].Fix(VELOCITY_Z); -NODES[4785].Fix(VELOCITY_X); -NODES[4785].Fix(VELOCITY_Y); -NODES[4785].Fix(VELOCITY_Z); -NODES[4786].Fix(VELOCITY_X); -NODES[4786].Fix(VELOCITY_Y); -NODES[4786].Fix(VELOCITY_Z); -NODES[4789].Fix(VELOCITY_X); -NODES[4789].Fix(VELOCITY_Y); -NODES[4789].Fix(VELOCITY_Z); -NODES[4790].Fix(VELOCITY_X); -NODES[4790].Fix(VELOCITY_Y); -NODES[4790].Fix(VELOCITY_Z); -NODES[4823].Fix(VELOCITY_X); -NODES[4823].Fix(VELOCITY_Y); -NODES[4823].Fix(VELOCITY_Z); -NODES[4824].Fix(VELOCITY_X); -NODES[4824].Fix(VELOCITY_Y); -NODES[4824].Fix(VELOCITY_Z); -NODES[4836].Fix(VELOCITY_X); -NODES[4836].Fix(VELOCITY_Y); -NODES[4836].Fix(VELOCITY_Z); -NODES[4847].Fix(VELOCITY_X); -NODES[4847].Fix(VELOCITY_Y); -NODES[4847].Fix(VELOCITY_Z); -NODES[4848].Fix(VELOCITY_X); -NODES[4848].Fix(VELOCITY_Y); -NODES[4848].Fix(VELOCITY_Z); -NODES[4856].Fix(VELOCITY_X); -NODES[4856].Fix(VELOCITY_Y); -NODES[4856].Fix(VELOCITY_Z); -NODES[4865].Fix(VELOCITY_X); -NODES[4865].Fix(VELOCITY_Y); -NODES[4865].Fix(VELOCITY_Z); -NODES[4866].Fix(VELOCITY_X); -NODES[4866].Fix(VELOCITY_Y); -NODES[4866].Fix(VELOCITY_Z); -NODES[4868].Fix(VELOCITY_X); -NODES[4868].Fix(VELOCITY_Y); -NODES[4868].Fix(VELOCITY_Z); -NODES[4869].Fix(VELOCITY_X); -NODES[4869].Fix(VELOCITY_Y); -NODES[4869].Fix(VELOCITY_Z); -NODES[4877].Fix(VELOCITY_X); -NODES[4877].Fix(VELOCITY_Y); -NODES[4877].Fix(VELOCITY_Z); -NODES[4886].Fix(VELOCITY_X); -NODES[4886].Fix(VELOCITY_Y); -NODES[4886].Fix(VELOCITY_Z); -NODES[4895].Fix(VELOCITY_X); -NODES[4895].Fix(VELOCITY_Y); -NODES[4895].Fix(VELOCITY_Z); -NODES[4904].Fix(VELOCITY_X); -NODES[4904].Fix(VELOCITY_Y); -NODES[4904].Fix(VELOCITY_Z); -NODES[4908].Fix(VELOCITY_X); -NODES[4908].Fix(VELOCITY_Y); -NODES[4908].Fix(VELOCITY_Z); -NODES[4917].Fix(VELOCITY_X); -NODES[4917].Fix(VELOCITY_Y); -NODES[4917].Fix(VELOCITY_Z); -NODES[4925].Fix(VELOCITY_X); -NODES[4925].Fix(VELOCITY_Y); -NODES[4925].Fix(VELOCITY_Z); -NODES[4931].Fix(VELOCITY_X); -NODES[4931].Fix(VELOCITY_Y); -NODES[4931].Fix(VELOCITY_Z); -NODES[4932].Fix(VELOCITY_X); -NODES[4932].Fix(VELOCITY_Y); -NODES[4932].Fix(VELOCITY_Z); -NODES[4945].Fix(VELOCITY_X); -NODES[4945].Fix(VELOCITY_Y); -NODES[4945].Fix(VELOCITY_Z); -NODES[4960].Fix(VELOCITY_X); -NODES[4960].Fix(VELOCITY_Y); -NODES[4960].Fix(VELOCITY_Z); -NODES[4961].Fix(VELOCITY_X); -NODES[4961].Fix(VELOCITY_Y); -NODES[4961].Fix(VELOCITY_Z); -NODES[4966].Fix(VELOCITY_X); -NODES[4966].Fix(VELOCITY_Y); -NODES[4966].Fix(VELOCITY_Z); -NODES[4967].Fix(VELOCITY_X); -NODES[4967].Fix(VELOCITY_Y); -NODES[4967].Fix(VELOCITY_Z); -NODES[4970].Fix(VELOCITY_X); -NODES[4970].Fix(VELOCITY_Y); -NODES[4970].Fix(VELOCITY_Z); -NODES[4981].Fix(VELOCITY_X); -NODES[4981].Fix(VELOCITY_Y); -NODES[4981].Fix(VELOCITY_Z); -NODES[4982].Fix(VELOCITY_X); -NODES[4982].Fix(VELOCITY_Y); -NODES[4982].Fix(VELOCITY_Z); -NODES[4984].Fix(VELOCITY_X); -NODES[4984].Fix(VELOCITY_Y); -NODES[4984].Fix(VELOCITY_Z); -NODES[4988].Fix(VELOCITY_X); -NODES[4988].Fix(VELOCITY_Y); -NODES[4988].Fix(VELOCITY_Z); -NODES[4995].Fix(VELOCITY_X); -NODES[4995].Fix(VELOCITY_Y); -NODES[4995].Fix(VELOCITY_Z); -NODES[5000].Fix(VELOCITY_X); -NODES[5000].Fix(VELOCITY_Y); -NODES[5000].Fix(VELOCITY_Z); -NODES[5001].Fix(VELOCITY_X); -NODES[5001].Fix(VELOCITY_Y); -NODES[5001].Fix(VELOCITY_Z); -NODES[5011].Fix(VELOCITY_X); -NODES[5011].Fix(VELOCITY_Y); -NODES[5011].Fix(VELOCITY_Z); -NODES[5012].Fix(VELOCITY_X); -NODES[5012].Fix(VELOCITY_Y); -NODES[5012].Fix(VELOCITY_Z); -NODES[5024].Fix(VELOCITY_X); -NODES[5024].Fix(VELOCITY_Y); -NODES[5024].Fix(VELOCITY_Z); -NODES[5027].Fix(VELOCITY_X); -NODES[5027].Fix(VELOCITY_Y); -NODES[5027].Fix(VELOCITY_Z); -NODES[5029].Fix(VELOCITY_X); -NODES[5029].Fix(VELOCITY_Y); -NODES[5029].Fix(VELOCITY_Z); -NODES[5034].Fix(VELOCITY_X); -NODES[5034].Fix(VELOCITY_Y); -NODES[5034].Fix(VELOCITY_Z); -NODES[5041].Fix(VELOCITY_X); -NODES[5041].Fix(VELOCITY_Y); -NODES[5041].Fix(VELOCITY_Z); -NODES[5042].Fix(VELOCITY_X); -NODES[5042].Fix(VELOCITY_Y); -NODES[5042].Fix(VELOCITY_Z); -NODES[5066].Fix(VELOCITY_X); -NODES[5066].Fix(VELOCITY_Y); -NODES[5066].Fix(VELOCITY_Z); -NODES[5067].Fix(VELOCITY_X); -NODES[5067].Fix(VELOCITY_Y); -NODES[5067].Fix(VELOCITY_Z); -NODES[5071].Fix(VELOCITY_X); -NODES[5071].Fix(VELOCITY_Y); -NODES[5071].Fix(VELOCITY_Z); -NODES[5080].Fix(VELOCITY_X); -NODES[5080].Fix(VELOCITY_Y); -NODES[5080].Fix(VELOCITY_Z); -NODES[5083].Fix(VELOCITY_X); -NODES[5083].Fix(VELOCITY_Y); -NODES[5083].Fix(VELOCITY_Z); -NODES[5085].Fix(VELOCITY_X); -NODES[5085].Fix(VELOCITY_Y); -NODES[5085].Fix(VELOCITY_Z); -NODES[5101].Fix(VELOCITY_X); -NODES[5101].Fix(VELOCITY_Y); -NODES[5101].Fix(VELOCITY_Z); -NODES[5102].Fix(VELOCITY_X); -NODES[5102].Fix(VELOCITY_Y); -NODES[5102].Fix(VELOCITY_Z); -NODES[5104].Fix(VELOCITY_X); -NODES[5104].Fix(VELOCITY_Y); -NODES[5104].Fix(VELOCITY_Z); -NODES[5117].Fix(VELOCITY_X); -NODES[5117].Fix(VELOCITY_Y); -NODES[5117].Fix(VELOCITY_Z); -NODES[5134].Fix(VELOCITY_X); -NODES[5134].Fix(VELOCITY_Y); -NODES[5134].Fix(VELOCITY_Z); -NODES[5141].Fix(VELOCITY_X); -NODES[5141].Fix(VELOCITY_Y); -NODES[5141].Fix(VELOCITY_Z); -NODES[5142].Fix(VELOCITY_X); -NODES[5142].Fix(VELOCITY_Y); -NODES[5142].Fix(VELOCITY_Z); -NODES[5147].Fix(VELOCITY_X); -NODES[5147].Fix(VELOCITY_Y); -NODES[5147].Fix(VELOCITY_Z); -NODES[5154].Fix(VELOCITY_X); -NODES[5154].Fix(VELOCITY_Y); -NODES[5154].Fix(VELOCITY_Z); -NODES[5160].Fix(VELOCITY_X); -NODES[5160].Fix(VELOCITY_Y); -NODES[5160].Fix(VELOCITY_Z); -NODES[5161].Fix(VELOCITY_X); -NODES[5161].Fix(VELOCITY_Y); -NODES[5161].Fix(VELOCITY_Z); -NODES[5163].Fix(VELOCITY_X); -NODES[5163].Fix(VELOCITY_Y); -NODES[5163].Fix(VELOCITY_Z); -NODES[5177].Fix(VELOCITY_X); -NODES[5177].Fix(VELOCITY_Y); -NODES[5177].Fix(VELOCITY_Z); -NODES[5180].Fix(VELOCITY_X); -NODES[5180].Fix(VELOCITY_Y); -NODES[5180].Fix(VELOCITY_Z); -NODES[5181].Fix(VELOCITY_X); -NODES[5181].Fix(VELOCITY_Y); -NODES[5181].Fix(VELOCITY_Z); -NODES[5185].Fix(VELOCITY_X); -NODES[5185].Fix(VELOCITY_Y); -NODES[5185].Fix(VELOCITY_Z); -NODES[5198].Fix(VELOCITY_X); -NODES[5198].Fix(VELOCITY_Y); -NODES[5198].Fix(VELOCITY_Z); -NODES[5199].Fix(VELOCITY_X); -NODES[5199].Fix(VELOCITY_Y); -NODES[5199].Fix(VELOCITY_Z); -NODES[5221].Fix(VELOCITY_X); -NODES[5221].Fix(VELOCITY_Y); -NODES[5221].Fix(VELOCITY_Z); -NODES[5222].Fix(VELOCITY_X); -NODES[5222].Fix(VELOCITY_Y); -NODES[5222].Fix(VELOCITY_Z); -NODES[5230].Fix(VELOCITY_X); -NODES[5230].Fix(VELOCITY_Y); -NODES[5230].Fix(VELOCITY_Z); -NODES[5233].Fix(VELOCITY_X); -NODES[5233].Fix(VELOCITY_Y); -NODES[5233].Fix(VELOCITY_Z); -NODES[5246].Fix(VELOCITY_X); -NODES[5246].Fix(VELOCITY_Y); -NODES[5246].Fix(VELOCITY_Z); -NODES[5247].Fix(VELOCITY_X); -NODES[5247].Fix(VELOCITY_Y); -NODES[5247].Fix(VELOCITY_Z); -NODES[5253].Fix(VELOCITY_X); -NODES[5253].Fix(VELOCITY_Y); -NODES[5253].Fix(VELOCITY_Z); -NODES[5254].Fix(VELOCITY_X); -NODES[5254].Fix(VELOCITY_Y); -NODES[5254].Fix(VELOCITY_Z); -NODES[5257].Fix(VELOCITY_X); -NODES[5257].Fix(VELOCITY_Y); -NODES[5257].Fix(VELOCITY_Z); -NODES[5259].Fix(VELOCITY_X); -NODES[5259].Fix(VELOCITY_Y); -NODES[5259].Fix(VELOCITY_Z); -NODES[5260].Fix(VELOCITY_X); -NODES[5260].Fix(VELOCITY_Y); -NODES[5260].Fix(VELOCITY_Z); -NODES[5262].Fix(VELOCITY_X); -NODES[5262].Fix(VELOCITY_Y); -NODES[5262].Fix(VELOCITY_Z); -NODES[5263].Fix(VELOCITY_X); -NODES[5263].Fix(VELOCITY_Y); -NODES[5263].Fix(VELOCITY_Z); -NODES[5271].Fix(VELOCITY_X); -NODES[5271].Fix(VELOCITY_Y); -NODES[5271].Fix(VELOCITY_Z); -NODES[5275].Fix(VELOCITY_X); -NODES[5275].Fix(VELOCITY_Y); -NODES[5275].Fix(VELOCITY_Z); -NODES[5281].Fix(VELOCITY_X); -NODES[5281].Fix(VELOCITY_Y); -NODES[5281].Fix(VELOCITY_Z); -NODES[5289].Fix(VELOCITY_X); -NODES[5289].Fix(VELOCITY_Y); -NODES[5289].Fix(VELOCITY_Z); -NODES[5290].Fix(VELOCITY_X); -NODES[5290].Fix(VELOCITY_Y); -NODES[5290].Fix(VELOCITY_Z); -NODES[5291].Fix(VELOCITY_X); -NODES[5291].Fix(VELOCITY_Y); -NODES[5291].Fix(VELOCITY_Z); -NODES[5308].Fix(VELOCITY_X); -NODES[5308].Fix(VELOCITY_Y); -NODES[5308].Fix(VELOCITY_Z); -NODES[5325].Fix(VELOCITY_X); -NODES[5325].Fix(VELOCITY_Y); -NODES[5325].Fix(VELOCITY_Z); -NODES[5333].Fix(VELOCITY_X); -NODES[5333].Fix(VELOCITY_Y); -NODES[5333].Fix(VELOCITY_Z); -NODES[5334].Fix(VELOCITY_X); -NODES[5334].Fix(VELOCITY_Y); -NODES[5334].Fix(VELOCITY_Z); -NODES[5336].Fix(VELOCITY_X); -NODES[5336].Fix(VELOCITY_Y); -NODES[5336].Fix(VELOCITY_Z); -NODES[5337].Fix(VELOCITY_X); -NODES[5337].Fix(VELOCITY_Y); -NODES[5337].Fix(VELOCITY_Z); -NODES[5341].Fix(VELOCITY_X); -NODES[5341].Fix(VELOCITY_Y); -NODES[5341].Fix(VELOCITY_Z); -NODES[5343].Fix(VELOCITY_X); -NODES[5343].Fix(VELOCITY_Y); -NODES[5343].Fix(VELOCITY_Z); -NODES[5344].Fix(VELOCITY_X); -NODES[5344].Fix(VELOCITY_Y); -NODES[5344].Fix(VELOCITY_Z); -NODES[5357].Fix(VELOCITY_X); -NODES[5357].Fix(VELOCITY_Y); -NODES[5357].Fix(VELOCITY_Z); -NODES[5362].Fix(VELOCITY_X); -NODES[5362].Fix(VELOCITY_Y); -NODES[5362].Fix(VELOCITY_Z); -NODES[5375].Fix(VELOCITY_X); -NODES[5375].Fix(VELOCITY_Y); -NODES[5375].Fix(VELOCITY_Z); -NODES[5376].Fix(VELOCITY_X); -NODES[5376].Fix(VELOCITY_Y); -NODES[5376].Fix(VELOCITY_Z); -NODES[5389].Fix(VELOCITY_X); -NODES[5389].Fix(VELOCITY_Y); -NODES[5389].Fix(VELOCITY_Z); -NODES[5404].Fix(VELOCITY_X); -NODES[5404].Fix(VELOCITY_Y); -NODES[5404].Fix(VELOCITY_Z); -NODES[5405].Fix(VELOCITY_X); -NODES[5405].Fix(VELOCITY_Y); -NODES[5405].Fix(VELOCITY_Z); -NODES[5407].Fix(VELOCITY_X); -NODES[5407].Fix(VELOCITY_Y); -NODES[5407].Fix(VELOCITY_Z); -NODES[5425].Fix(VELOCITY_X); -NODES[5425].Fix(VELOCITY_Y); -NODES[5425].Fix(VELOCITY_Z); -NODES[5427].Fix(VELOCITY_X); -NODES[5427].Fix(VELOCITY_Y); -NODES[5427].Fix(VELOCITY_Z); -NODES[5435].Fix(VELOCITY_X); -NODES[5435].Fix(VELOCITY_Y); -NODES[5435].Fix(VELOCITY_Z); -NODES[5440].Fix(VELOCITY_X); -NODES[5440].Fix(VELOCITY_Y); -NODES[5440].Fix(VELOCITY_Z); -NODES[5445].Fix(VELOCITY_X); -NODES[5445].Fix(VELOCITY_Y); -NODES[5445].Fix(VELOCITY_Z); -NODES[5446].Fix(VELOCITY_X); -NODES[5446].Fix(VELOCITY_Y); -NODES[5446].Fix(VELOCITY_Z); -NODES[5480].Fix(VELOCITY_X); -NODES[5480].Fix(VELOCITY_Y); -NODES[5480].Fix(VELOCITY_Z); -NODES[5487].Fix(VELOCITY_X); -NODES[5487].Fix(VELOCITY_Y); -NODES[5487].Fix(VELOCITY_Z); -NODES[5491].Fix(VELOCITY_X); -NODES[5491].Fix(VELOCITY_Y); -NODES[5491].Fix(VELOCITY_Z); -NODES[5492].Fix(VELOCITY_X); -NODES[5492].Fix(VELOCITY_Y); -NODES[5492].Fix(VELOCITY_Z); -NODES[5496].Fix(VELOCITY_X); -NODES[5496].Fix(VELOCITY_Y); -NODES[5496].Fix(VELOCITY_Z); -NODES[5497].Fix(VELOCITY_X); -NODES[5497].Fix(VELOCITY_Y); -NODES[5497].Fix(VELOCITY_Z); -NODES[5499].Fix(VELOCITY_X); -NODES[5499].Fix(VELOCITY_Y); -NODES[5499].Fix(VELOCITY_Z); -NODES[5500].Fix(VELOCITY_X); -NODES[5500].Fix(VELOCITY_Y); -NODES[5500].Fix(VELOCITY_Z); -NODES[5501].Fix(VELOCITY_X); -NODES[5501].Fix(VELOCITY_Y); -NODES[5501].Fix(VELOCITY_Z); -NODES[5502].Fix(VELOCITY_X); -NODES[5502].Fix(VELOCITY_Y); -NODES[5502].Fix(VELOCITY_Z); -NODES[5503].Fix(VELOCITY_X); -NODES[5503].Fix(VELOCITY_Y); -NODES[5503].Fix(VELOCITY_Z); -NODES[5505].Fix(VELOCITY_X); -NODES[5505].Fix(VELOCITY_Y); -NODES[5505].Fix(VELOCITY_Z); -NODES[5510].Fix(VELOCITY_X); -NODES[5510].Fix(VELOCITY_Y); -NODES[5510].Fix(VELOCITY_Z); -NODES[5519].Fix(VELOCITY_X); -NODES[5519].Fix(VELOCITY_Y); -NODES[5519].Fix(VELOCITY_Z); -NODES[5528].Fix(VELOCITY_X); -NODES[5528].Fix(VELOCITY_Y); -NODES[5528].Fix(VELOCITY_Z); -NODES[5533].Fix(VELOCITY_X); -NODES[5533].Fix(VELOCITY_Y); -NODES[5533].Fix(VELOCITY_Z); -NODES[5534].Fix(VELOCITY_X); -NODES[5534].Fix(VELOCITY_Y); -NODES[5534].Fix(VELOCITY_Z); -NODES[5540].Fix(VELOCITY_X); -NODES[5540].Fix(VELOCITY_Y); -NODES[5540].Fix(VELOCITY_Z); -NODES[5548].Fix(VELOCITY_X); -NODES[5548].Fix(VELOCITY_Y); -NODES[5548].Fix(VELOCITY_Z); -NODES[5550].Fix(VELOCITY_X); -NODES[5550].Fix(VELOCITY_Y); -NODES[5550].Fix(VELOCITY_Z); -NODES[5551].Fix(VELOCITY_X); -NODES[5551].Fix(VELOCITY_Y); -NODES[5551].Fix(VELOCITY_Z); -NODES[5563].Fix(VELOCITY_X); -NODES[5563].Fix(VELOCITY_Y); -NODES[5563].Fix(VELOCITY_Z); -NODES[5568].Fix(VELOCITY_X); -NODES[5568].Fix(VELOCITY_Y); -NODES[5568].Fix(VELOCITY_Z); -NODES[5575].Fix(VELOCITY_X); -NODES[5575].Fix(VELOCITY_Y); -NODES[5575].Fix(VELOCITY_Z); -NODES[5579].Fix(VELOCITY_X); -NODES[5579].Fix(VELOCITY_Y); -NODES[5579].Fix(VELOCITY_Z); -NODES[5580].Fix(VELOCITY_X); -NODES[5580].Fix(VELOCITY_Y); -NODES[5580].Fix(VELOCITY_Z); -NODES[5587].Fix(VELOCITY_X); -NODES[5587].Fix(VELOCITY_Y); -NODES[5587].Fix(VELOCITY_Z); -NODES[5596].Fix(VELOCITY_X); -NODES[5596].Fix(VELOCITY_Y); -NODES[5596].Fix(VELOCITY_Z); -NODES[5597].Fix(VELOCITY_X); -NODES[5597].Fix(VELOCITY_Y); -NODES[5597].Fix(VELOCITY_Z); -NODES[5598].Fix(VELOCITY_X); -NODES[5598].Fix(VELOCITY_Y); -NODES[5598].Fix(VELOCITY_Z); -NODES[5618].Fix(VELOCITY_X); -NODES[5618].Fix(VELOCITY_Y); -NODES[5618].Fix(VELOCITY_Z); -NODES[5619].Fix(VELOCITY_X); -NODES[5619].Fix(VELOCITY_Y); -NODES[5619].Fix(VELOCITY_Z); -NODES[5620].Fix(VELOCITY_X); -NODES[5620].Fix(VELOCITY_Y); -NODES[5620].Fix(VELOCITY_Z); -NODES[5630].Fix(VELOCITY_X); -NODES[5630].Fix(VELOCITY_Y); -NODES[5630].Fix(VELOCITY_Z); -NODES[5638].Fix(VELOCITY_X); -NODES[5638].Fix(VELOCITY_Y); -NODES[5638].Fix(VELOCITY_Z); -NODES[5646].Fix(VELOCITY_X); -NODES[5646].Fix(VELOCITY_Y); -NODES[5646].Fix(VELOCITY_Z); -NODES[5647].Fix(VELOCITY_X); -NODES[5647].Fix(VELOCITY_Y); -NODES[5647].Fix(VELOCITY_Z); -NODES[5662].Fix(VELOCITY_X); -NODES[5662].Fix(VELOCITY_Y); -NODES[5662].Fix(VELOCITY_Z); -NODES[5678].Fix(VELOCITY_X); -NODES[5678].Fix(VELOCITY_Y); -NODES[5678].Fix(VELOCITY_Z); -NODES[5692].Fix(VELOCITY_X); -NODES[5692].Fix(VELOCITY_Y); -NODES[5692].Fix(VELOCITY_Z); -NODES[5693].Fix(VELOCITY_X); -NODES[5693].Fix(VELOCITY_Y); -NODES[5693].Fix(VELOCITY_Z); -NODES[5698].Fix(VELOCITY_X); -NODES[5698].Fix(VELOCITY_Y); -NODES[5698].Fix(VELOCITY_Z); -NODES[5705].Fix(VELOCITY_X); -NODES[5705].Fix(VELOCITY_Y); -NODES[5705].Fix(VELOCITY_Z); -NODES[5721].Fix(VELOCITY_X); -NODES[5721].Fix(VELOCITY_Y); -NODES[5721].Fix(VELOCITY_Z); -NODES[5722].Fix(VELOCITY_X); -NODES[5722].Fix(VELOCITY_Y); -NODES[5722].Fix(VELOCITY_Z); -NODES[5734].Fix(VELOCITY_X); -NODES[5734].Fix(VELOCITY_Y); -NODES[5734].Fix(VELOCITY_Z); -NODES[5735].Fix(VELOCITY_X); -NODES[5735].Fix(VELOCITY_Y); -NODES[5735].Fix(VELOCITY_Z); -NODES[5736].Fix(VELOCITY_X); -NODES[5736].Fix(VELOCITY_Y); -NODES[5736].Fix(VELOCITY_Z); -NODES[5746].Fix(VELOCITY_X); -NODES[5746].Fix(VELOCITY_Y); -NODES[5746].Fix(VELOCITY_Z); -NODES[5760].Fix(VELOCITY_X); -NODES[5760].Fix(VELOCITY_Y); -NODES[5760].Fix(VELOCITY_Z); -NODES[5768].Fix(VELOCITY_X); -NODES[5768].Fix(VELOCITY_Y); -NODES[5768].Fix(VELOCITY_Z); -NODES[5774].Fix(VELOCITY_X); -NODES[5774].Fix(VELOCITY_Y); -NODES[5774].Fix(VELOCITY_Z); -NODES[5782].Fix(VELOCITY_X); -NODES[5782].Fix(VELOCITY_Y); -NODES[5782].Fix(VELOCITY_Z); -NODES[5792].Fix(VELOCITY_X); -NODES[5792].Fix(VELOCITY_Y); -NODES[5792].Fix(VELOCITY_Z); -NODES[5799].Fix(VELOCITY_X); -NODES[5799].Fix(VELOCITY_Y); -NODES[5799].Fix(VELOCITY_Z); -NODES[5815].Fix(VELOCITY_X); -NODES[5815].Fix(VELOCITY_Y); -NODES[5815].Fix(VELOCITY_Z); -NODES[5820].Fix(VELOCITY_X); -NODES[5820].Fix(VELOCITY_Y); -NODES[5820].Fix(VELOCITY_Z); -NODES[5832].Fix(VELOCITY_X); -NODES[5832].Fix(VELOCITY_Y); -NODES[5832].Fix(VELOCITY_Z); -NODES[5836].Fix(VELOCITY_X); -NODES[5836].Fix(VELOCITY_Y); -NODES[5836].Fix(VELOCITY_Z); -NODES[5837].Fix(VELOCITY_X); -NODES[5837].Fix(VELOCITY_Y); -NODES[5837].Fix(VELOCITY_Z); -NODES[5850].Fix(VELOCITY_X); -NODES[5850].Fix(VELOCITY_Y); -NODES[5850].Fix(VELOCITY_Z); -NODES[5859].Fix(VELOCITY_X); -NODES[5859].Fix(VELOCITY_Y); -NODES[5859].Fix(VELOCITY_Z); -NODES[5860].Fix(VELOCITY_X); -NODES[5860].Fix(VELOCITY_Y); -NODES[5860].Fix(VELOCITY_Z); -NODES[5862].Fix(VELOCITY_X); -NODES[5862].Fix(VELOCITY_Y); -NODES[5862].Fix(VELOCITY_Z); -NODES[5867].Fix(VELOCITY_X); -NODES[5867].Fix(VELOCITY_Y); -NODES[5867].Fix(VELOCITY_Z); -NODES[5868].Fix(VELOCITY_X); -NODES[5868].Fix(VELOCITY_Y); -NODES[5868].Fix(VELOCITY_Z); -NODES[5876].Fix(VELOCITY_X); -NODES[5876].Fix(VELOCITY_Y); -NODES[5876].Fix(VELOCITY_Z); -NODES[5877].Fix(VELOCITY_X); -NODES[5877].Fix(VELOCITY_Y); -NODES[5877].Fix(VELOCITY_Z); -NODES[5899].Fix(VELOCITY_X); -NODES[5899].Fix(VELOCITY_Y); -NODES[5899].Fix(VELOCITY_Z); -NODES[5900].Fix(VELOCITY_X); -NODES[5900].Fix(VELOCITY_Y); -NODES[5900].Fix(VELOCITY_Z); -NODES[5901].Fix(VELOCITY_X); -NODES[5901].Fix(VELOCITY_Y); -NODES[5901].Fix(VELOCITY_Z); -NODES[5903].Fix(VELOCITY_X); -NODES[5903].Fix(VELOCITY_Y); -NODES[5903].Fix(VELOCITY_Z); -NODES[5904].Fix(VELOCITY_X); -NODES[5904].Fix(VELOCITY_Y); -NODES[5904].Fix(VELOCITY_Z); -NODES[5906].Fix(VELOCITY_X); -NODES[5906].Fix(VELOCITY_Y); -NODES[5906].Fix(VELOCITY_Z); -NODES[5920].Fix(VELOCITY_X); -NODES[5920].Fix(VELOCITY_Y); -NODES[5920].Fix(VELOCITY_Z); -NODES[5925].Fix(VELOCITY_X); -NODES[5925].Fix(VELOCITY_Y); -NODES[5925].Fix(VELOCITY_Z); -NODES[5931].Fix(VELOCITY_X); -NODES[5931].Fix(VELOCITY_Y); -NODES[5931].Fix(VELOCITY_Z); -NODES[5938].Fix(VELOCITY_X); -NODES[5938].Fix(VELOCITY_Y); -NODES[5938].Fix(VELOCITY_Z); -NODES[5939].Fix(VELOCITY_X); -NODES[5939].Fix(VELOCITY_Y); -NODES[5939].Fix(VELOCITY_Z); -NODES[5946].Fix(VELOCITY_X); -NODES[5946].Fix(VELOCITY_Y); -NODES[5946].Fix(VELOCITY_Z); -NODES[5960].Fix(VELOCITY_X); -NODES[5960].Fix(VELOCITY_Y); -NODES[5960].Fix(VELOCITY_Z); -NODES[5961].Fix(VELOCITY_X); -NODES[5961].Fix(VELOCITY_Y); -NODES[5961].Fix(VELOCITY_Z); -NODES[5962].Fix(VELOCITY_X); -NODES[5962].Fix(VELOCITY_Y); -NODES[5962].Fix(VELOCITY_Z); -NODES[5964].Fix(VELOCITY_X); -NODES[5964].Fix(VELOCITY_Y); -NODES[5964].Fix(VELOCITY_Z); -NODES[5972].Fix(VELOCITY_X); -NODES[5972].Fix(VELOCITY_Y); -NODES[5972].Fix(VELOCITY_Z); -NODES[5987].Fix(VELOCITY_X); -NODES[5987].Fix(VELOCITY_Y); -NODES[5987].Fix(VELOCITY_Z); -NODES[5988].Fix(VELOCITY_X); -NODES[5988].Fix(VELOCITY_Y); -NODES[5988].Fix(VELOCITY_Z); -NODES[6016].Fix(VELOCITY_X); -NODES[6016].Fix(VELOCITY_Y); -NODES[6016].Fix(VELOCITY_Z); -NODES[6025].Fix(VELOCITY_X); -NODES[6025].Fix(VELOCITY_Y); -NODES[6025].Fix(VELOCITY_Z); -NODES[6026].Fix(VELOCITY_X); -NODES[6026].Fix(VELOCITY_Y); -NODES[6026].Fix(VELOCITY_Z); -NODES[6033].Fix(VELOCITY_X); -NODES[6033].Fix(VELOCITY_Y); -NODES[6033].Fix(VELOCITY_Z); -NODES[6036].Fix(VELOCITY_X); -NODES[6036].Fix(VELOCITY_Y); -NODES[6036].Fix(VELOCITY_Z); -NODES[6041].Fix(VELOCITY_X); -NODES[6041].Fix(VELOCITY_Y); -NODES[6041].Fix(VELOCITY_Z); -NODES[6045].Fix(VELOCITY_X); -NODES[6045].Fix(VELOCITY_Y); -NODES[6045].Fix(VELOCITY_Z); -NODES[6054].Fix(VELOCITY_X); -NODES[6054].Fix(VELOCITY_Y); -NODES[6054].Fix(VELOCITY_Z); -NODES[6056].Fix(VELOCITY_X); -NODES[6056].Fix(VELOCITY_Y); -NODES[6056].Fix(VELOCITY_Z); -NODES[6057].Fix(VELOCITY_X); -NODES[6057].Fix(VELOCITY_Y); -NODES[6057].Fix(VELOCITY_Z); -NODES[6070].Fix(VELOCITY_X); -NODES[6070].Fix(VELOCITY_Y); -NODES[6070].Fix(VELOCITY_Z); -NODES[6071].Fix(VELOCITY_X); -NODES[6071].Fix(VELOCITY_Y); -NODES[6071].Fix(VELOCITY_Z); -NODES[6074].Fix(VELOCITY_X); -NODES[6074].Fix(VELOCITY_Y); -NODES[6074].Fix(VELOCITY_Z); -NODES[6077].Fix(VELOCITY_X); -NODES[6077].Fix(VELOCITY_Y); -NODES[6077].Fix(VELOCITY_Z); -NODES[6085].Fix(VELOCITY_X); -NODES[6085].Fix(VELOCITY_Y); -NODES[6085].Fix(VELOCITY_Z); -NODES[6089].Fix(VELOCITY_X); -NODES[6089].Fix(VELOCITY_Y); -NODES[6089].Fix(VELOCITY_Z); -NODES[6095].Fix(VELOCITY_X); -NODES[6095].Fix(VELOCITY_Y); -NODES[6095].Fix(VELOCITY_Z); -NODES[6096].Fix(VELOCITY_X); -NODES[6096].Fix(VELOCITY_Y); -NODES[6096].Fix(VELOCITY_Z); -NODES[6107].Fix(VELOCITY_X); -NODES[6107].Fix(VELOCITY_Y); -NODES[6107].Fix(VELOCITY_Z); -NODES[6108].Fix(VELOCITY_X); -NODES[6108].Fix(VELOCITY_Y); -NODES[6108].Fix(VELOCITY_Z); -NODES[6122].Fix(VELOCITY_X); -NODES[6122].Fix(VELOCITY_Y); -NODES[6122].Fix(VELOCITY_Z); -NODES[6124].Fix(VELOCITY_X); -NODES[6124].Fix(VELOCITY_Y); -NODES[6124].Fix(VELOCITY_Z); -NODES[6128].Fix(VELOCITY_X); -NODES[6128].Fix(VELOCITY_Y); -NODES[6128].Fix(VELOCITY_Z); -NODES[6129].Fix(VELOCITY_X); -NODES[6129].Fix(VELOCITY_Y); -NODES[6129].Fix(VELOCITY_Z); -NODES[6135].Fix(VELOCITY_X); -NODES[6135].Fix(VELOCITY_Y); -NODES[6135].Fix(VELOCITY_Z); -NODES[6136].Fix(VELOCITY_X); -NODES[6136].Fix(VELOCITY_Y); -NODES[6136].Fix(VELOCITY_Z); -NODES[6145].Fix(VELOCITY_X); -NODES[6145].Fix(VELOCITY_Y); -NODES[6145].Fix(VELOCITY_Z); -NODES[6154].Fix(VELOCITY_X); -NODES[6154].Fix(VELOCITY_Y); -NODES[6154].Fix(VELOCITY_Z); -NODES[6155].Fix(VELOCITY_X); -NODES[6155].Fix(VELOCITY_Y); -NODES[6155].Fix(VELOCITY_Z); -NODES[6175].Fix(VELOCITY_X); -NODES[6175].Fix(VELOCITY_Y); -NODES[6175].Fix(VELOCITY_Z); -NODES[6176].Fix(VELOCITY_X); -NODES[6176].Fix(VELOCITY_Y); -NODES[6176].Fix(VELOCITY_Z); -NODES[6195].Fix(VELOCITY_X); -NODES[6195].Fix(VELOCITY_Y); -NODES[6195].Fix(VELOCITY_Z); -NODES[6205].Fix(VELOCITY_X); -NODES[6205].Fix(VELOCITY_Y); -NODES[6205].Fix(VELOCITY_Z); -NODES[6209].Fix(VELOCITY_X); -NODES[6209].Fix(VELOCITY_Y); -NODES[6209].Fix(VELOCITY_Z); -NODES[6241].Fix(VELOCITY_X); -NODES[6241].Fix(VELOCITY_Y); -NODES[6241].Fix(VELOCITY_Z); -NODES[6242].Fix(VELOCITY_X); -NODES[6242].Fix(VELOCITY_Y); -NODES[6242].Fix(VELOCITY_Z); -NODES[6246].Fix(VELOCITY_X); -NODES[6246].Fix(VELOCITY_Y); -NODES[6246].Fix(VELOCITY_Z); -NODES[6252].Fix(VELOCITY_X); -NODES[6252].Fix(VELOCITY_Y); -NODES[6252].Fix(VELOCITY_Z); -NODES[6267].Fix(VELOCITY_X); -NODES[6267].Fix(VELOCITY_Y); -NODES[6267].Fix(VELOCITY_Z); -NODES[6275].Fix(VELOCITY_X); -NODES[6275].Fix(VELOCITY_Y); -NODES[6275].Fix(VELOCITY_Z); -NODES[6276].Fix(VELOCITY_X); -NODES[6276].Fix(VELOCITY_Y); -NODES[6276].Fix(VELOCITY_Z); -NODES[6279].Fix(VELOCITY_X); -NODES[6279].Fix(VELOCITY_Y); -NODES[6279].Fix(VELOCITY_Z); -NODES[6280].Fix(VELOCITY_X); -NODES[6280].Fix(VELOCITY_Y); -NODES[6280].Fix(VELOCITY_Z); -NODES[6288].Fix(VELOCITY_X); -NODES[6288].Fix(VELOCITY_Y); -NODES[6288].Fix(VELOCITY_Z); -NODES[6289].Fix(VELOCITY_X); -NODES[6289].Fix(VELOCITY_Y); -NODES[6289].Fix(VELOCITY_Z); -NODES[6290].Fix(VELOCITY_X); -NODES[6290].Fix(VELOCITY_Y); -NODES[6290].Fix(VELOCITY_Z); -NODES[6291].Fix(VELOCITY_X); -NODES[6291].Fix(VELOCITY_Y); -NODES[6291].Fix(VELOCITY_Z); -NODES[6293].Fix(VELOCITY_X); -NODES[6293].Fix(VELOCITY_Y); -NODES[6293].Fix(VELOCITY_Z); -NODES[6309].Fix(VELOCITY_X); -NODES[6309].Fix(VELOCITY_Y); -NODES[6309].Fix(VELOCITY_Z); -NODES[6310].Fix(VELOCITY_X); -NODES[6310].Fix(VELOCITY_Y); -NODES[6310].Fix(VELOCITY_Z); -NODES[6322].Fix(VELOCITY_X); -NODES[6322].Fix(VELOCITY_Y); -NODES[6322].Fix(VELOCITY_Z); -NODES[6323].Fix(VELOCITY_X); -NODES[6323].Fix(VELOCITY_Y); -NODES[6323].Fix(VELOCITY_Z); -NODES[6324].Fix(VELOCITY_X); -NODES[6324].Fix(VELOCITY_Y); -NODES[6324].Fix(VELOCITY_Z); -NODES[6325].Fix(VELOCITY_X); -NODES[6325].Fix(VELOCITY_Y); -NODES[6325].Fix(VELOCITY_Z); -NODES[6326].Fix(VELOCITY_X); -NODES[6326].Fix(VELOCITY_Y); -NODES[6326].Fix(VELOCITY_Z); -NODES[6327].Fix(VELOCITY_X); -NODES[6327].Fix(VELOCITY_Y); -NODES[6327].Fix(VELOCITY_Z); -NODES[6328].Fix(VELOCITY_X); -NODES[6328].Fix(VELOCITY_Y); -NODES[6328].Fix(VELOCITY_Z); -NODES[6343].Fix(VELOCITY_X); -NODES[6343].Fix(VELOCITY_Y); -NODES[6343].Fix(VELOCITY_Z); -NODES[6344].Fix(VELOCITY_X); -NODES[6344].Fix(VELOCITY_Y); -NODES[6344].Fix(VELOCITY_Z); -NODES[6356].Fix(VELOCITY_X); -NODES[6356].Fix(VELOCITY_Y); -NODES[6356].Fix(VELOCITY_Z); -NODES[6357].Fix(VELOCITY_X); -NODES[6357].Fix(VELOCITY_Y); -NODES[6357].Fix(VELOCITY_Z); -NODES[6358].Fix(VELOCITY_X); -NODES[6358].Fix(VELOCITY_Y); -NODES[6358].Fix(VELOCITY_Z); -NODES[6359].Fix(VELOCITY_X); -NODES[6359].Fix(VELOCITY_Y); -NODES[6359].Fix(VELOCITY_Z); -NODES[6377].Fix(VELOCITY_X); -NODES[6377].Fix(VELOCITY_Y); -NODES[6377].Fix(VELOCITY_Z); -NODES[6378].Fix(VELOCITY_X); -NODES[6378].Fix(VELOCITY_Y); -NODES[6378].Fix(VELOCITY_Z); -NODES[6379].Fix(VELOCITY_X); -NODES[6379].Fix(VELOCITY_Y); -NODES[6379].Fix(VELOCITY_Z); -NODES[6380].Fix(VELOCITY_X); -NODES[6380].Fix(VELOCITY_Y); -NODES[6380].Fix(VELOCITY_Z); -NODES[6381].Fix(VELOCITY_X); -NODES[6381].Fix(VELOCITY_Y); -NODES[6381].Fix(VELOCITY_Z); -NODES[6382].Fix(VELOCITY_X); -NODES[6382].Fix(VELOCITY_Y); -NODES[6382].Fix(VELOCITY_Z); -NODES[6384].Fix(VELOCITY_X); -NODES[6384].Fix(VELOCITY_Y); -NODES[6384].Fix(VELOCITY_Z); -NODES[6385].Fix(VELOCITY_X); -NODES[6385].Fix(VELOCITY_Y); -NODES[6385].Fix(VELOCITY_Z); -NODES[6392].Fix(VELOCITY_X); -NODES[6392].Fix(VELOCITY_Y); -NODES[6392].Fix(VELOCITY_Z); -NODES[6398].Fix(VELOCITY_X); -NODES[6398].Fix(VELOCITY_Y); -NODES[6398].Fix(VELOCITY_Z); -NODES[6400].Fix(VELOCITY_X); -NODES[6400].Fix(VELOCITY_Y); -NODES[6400].Fix(VELOCITY_Z); -NODES[6408].Fix(VELOCITY_X); -NODES[6408].Fix(VELOCITY_Y); -NODES[6408].Fix(VELOCITY_Z); -NODES[6409].Fix(VELOCITY_X); -NODES[6409].Fix(VELOCITY_Y); -NODES[6409].Fix(VELOCITY_Z); -NODES[6410].Fix(VELOCITY_X); -NODES[6410].Fix(VELOCITY_Y); -NODES[6410].Fix(VELOCITY_Z); -NODES[6420].Fix(VELOCITY_X); -NODES[6420].Fix(VELOCITY_Y); -NODES[6420].Fix(VELOCITY_Z); -NODES[6422].Fix(VELOCITY_X); -NODES[6422].Fix(VELOCITY_Y); -NODES[6422].Fix(VELOCITY_Z); -NODES[6423].Fix(VELOCITY_X); -NODES[6423].Fix(VELOCITY_Y); -NODES[6423].Fix(VELOCITY_Z); -NODES[6424].Fix(VELOCITY_X); -NODES[6424].Fix(VELOCITY_Y); -NODES[6424].Fix(VELOCITY_Z); -NODES[6425].Fix(VELOCITY_X); -NODES[6425].Fix(VELOCITY_Y); -NODES[6425].Fix(VELOCITY_Z); -NODES[6426].Fix(VELOCITY_X); -NODES[6426].Fix(VELOCITY_Y); -NODES[6426].Fix(VELOCITY_Z); -NODES[6434].Fix(VELOCITY_X); -NODES[6434].Fix(VELOCITY_Y); -NODES[6434].Fix(VELOCITY_Z); -NODES[6435].Fix(VELOCITY_X); -NODES[6435].Fix(VELOCITY_Y); -NODES[6435].Fix(VELOCITY_Z); -NODES[6436].Fix(VELOCITY_X); -NODES[6436].Fix(VELOCITY_Y); -NODES[6436].Fix(VELOCITY_Z); -NODES[6439].Fix(VELOCITY_X); -NODES[6439].Fix(VELOCITY_Y); -NODES[6439].Fix(VELOCITY_Z); -NODES[6440].Fix(VELOCITY_X); -NODES[6440].Fix(VELOCITY_Y); -NODES[6440].Fix(VELOCITY_Z); -NODES[6451].Fix(VELOCITY_X); -NODES[6451].Fix(VELOCITY_Y); -NODES[6451].Fix(VELOCITY_Z); -NODES[6452].Fix(VELOCITY_X); -NODES[6452].Fix(VELOCITY_Y); -NODES[6452].Fix(VELOCITY_Z); -NODES[6453].Fix(VELOCITY_X); -NODES[6453].Fix(VELOCITY_Y); -NODES[6453].Fix(VELOCITY_Z); -NODES[6454].Fix(VELOCITY_X); -NODES[6454].Fix(VELOCITY_Y); -NODES[6454].Fix(VELOCITY_Z); -NODES[6455].Fix(VELOCITY_X); -NODES[6455].Fix(VELOCITY_Y); -NODES[6455].Fix(VELOCITY_Z); -NODES[6469].Fix(VELOCITY_X); -NODES[6469].Fix(VELOCITY_Y); -NODES[6469].Fix(VELOCITY_Z); -NODES[6470].Fix(VELOCITY_X); -NODES[6470].Fix(VELOCITY_Y); -NODES[6470].Fix(VELOCITY_Z); -NODES[6473].Fix(VELOCITY_X); -NODES[6473].Fix(VELOCITY_Y); -NODES[6473].Fix(VELOCITY_Z); -NODES[6474].Fix(VELOCITY_X); -NODES[6474].Fix(VELOCITY_Y); -NODES[6474].Fix(VELOCITY_Z); -NODES[6478].Fix(VELOCITY_X); -NODES[6478].Fix(VELOCITY_Y); -NODES[6478].Fix(VELOCITY_Z); -NODES[6482].Fix(VELOCITY_X); -NODES[6482].Fix(VELOCITY_Y); -NODES[6482].Fix(VELOCITY_Z); -NODES[6484].Fix(VELOCITY_X); -NODES[6484].Fix(VELOCITY_Y); -NODES[6484].Fix(VELOCITY_Z); -NODES[6485].Fix(VELOCITY_X); -NODES[6485].Fix(VELOCITY_Y); -NODES[6485].Fix(VELOCITY_Z); -NODES[6486].Fix(VELOCITY_X); -NODES[6486].Fix(VELOCITY_Y); -NODES[6486].Fix(VELOCITY_Z); -NODES[6487].Fix(VELOCITY_X); -NODES[6487].Fix(VELOCITY_Y); -NODES[6487].Fix(VELOCITY_Z); -NODES[6499].Fix(VELOCITY_X); -NODES[6499].Fix(VELOCITY_Y); -NODES[6499].Fix(VELOCITY_Z); -NODES[6502].Fix(VELOCITY_X); -NODES[6502].Fix(VELOCITY_Y); -NODES[6502].Fix(VELOCITY_Z); -NODES[6506].Fix(VELOCITY_X); -NODES[6506].Fix(VELOCITY_Y); -NODES[6506].Fix(VELOCITY_Z); -NODES[6507].Fix(VELOCITY_X); -NODES[6507].Fix(VELOCITY_Y); -NODES[6507].Fix(VELOCITY_Z); -NODES[6508].Fix(VELOCITY_X); -NODES[6508].Fix(VELOCITY_Y); -NODES[6508].Fix(VELOCITY_Z); -NODES[6511].Fix(VELOCITY_X); -NODES[6511].Fix(VELOCITY_Y); -NODES[6511].Fix(VELOCITY_Z); -NODES[6529].Fix(VELOCITY_X); -NODES[6529].Fix(VELOCITY_Y); -NODES[6529].Fix(VELOCITY_Z); -NODES[6544].Fix(VELOCITY_X); -NODES[6544].Fix(VELOCITY_Y); -NODES[6544].Fix(VELOCITY_Z); -NODES[6545].Fix(VELOCITY_X); -NODES[6545].Fix(VELOCITY_Y); -NODES[6545].Fix(VELOCITY_Z); -NODES[6546].Fix(VELOCITY_X); -NODES[6546].Fix(VELOCITY_Y); -NODES[6546].Fix(VELOCITY_Z); -NODES[6547].Fix(VELOCITY_X); -NODES[6547].Fix(VELOCITY_Y); -NODES[6547].Fix(VELOCITY_Z); -NODES[6548].Fix(VELOCITY_X); -NODES[6548].Fix(VELOCITY_Y); -NODES[6548].Fix(VELOCITY_Z); -NODES[6549].Fix(VELOCITY_X); -NODES[6549].Fix(VELOCITY_Y); -NODES[6549].Fix(VELOCITY_Z); -NODES[6550].Fix(VELOCITY_X); -NODES[6550].Fix(VELOCITY_Y); -NODES[6550].Fix(VELOCITY_Z); -NODES[6561].Fix(VELOCITY_X); -NODES[6561].Fix(VELOCITY_Y); -NODES[6561].Fix(VELOCITY_Z); -NODES[6569].Fix(VELOCITY_X); -NODES[6569].Fix(VELOCITY_Y); -NODES[6569].Fix(VELOCITY_Z); -NODES[6570].Fix(VELOCITY_X); -NODES[6570].Fix(VELOCITY_Y); -NODES[6570].Fix(VELOCITY_Z); -NODES[6573].Fix(VELOCITY_X); -NODES[6573].Fix(VELOCITY_Y); -NODES[6573].Fix(VELOCITY_Z); -NODES[6577].Fix(VELOCITY_X); -NODES[6577].Fix(VELOCITY_Y); -NODES[6577].Fix(VELOCITY_Z); -NODES[6578].Fix(VELOCITY_X); -NODES[6578].Fix(VELOCITY_Y); -NODES[6578].Fix(VELOCITY_Z); -NODES[6579].Fix(VELOCITY_X); -NODES[6579].Fix(VELOCITY_Y); -NODES[6579].Fix(VELOCITY_Z); -NODES[6582].Fix(VELOCITY_X); -NODES[6582].Fix(VELOCITY_Y); -NODES[6582].Fix(VELOCITY_Z); -NODES[6593].Fix(VELOCITY_X); -NODES[6593].Fix(VELOCITY_Y); -NODES[6593].Fix(VELOCITY_Z); -NODES[6594].Fix(VELOCITY_X); -NODES[6594].Fix(VELOCITY_Y); -NODES[6594].Fix(VELOCITY_Z); -NODES[6595].Fix(VELOCITY_X); -NODES[6595].Fix(VELOCITY_Y); -NODES[6595].Fix(VELOCITY_Z); -NODES[6596].Fix(VELOCITY_X); -NODES[6596].Fix(VELOCITY_Y); -NODES[6596].Fix(VELOCITY_Z); -NODES[6597].Fix(VELOCITY_X); -NODES[6597].Fix(VELOCITY_Y); -NODES[6597].Fix(VELOCITY_Z); -NODES[6598].Fix(VELOCITY_X); -NODES[6598].Fix(VELOCITY_Y); -NODES[6598].Fix(VELOCITY_Z); -NODES[6603].Fix(VELOCITY_X); -NODES[6603].Fix(VELOCITY_Y); -NODES[6603].Fix(VELOCITY_Z); -NODES[6607].Fix(VELOCITY_X); -NODES[6607].Fix(VELOCITY_Y); -NODES[6607].Fix(VELOCITY_Z); -NODES[6609].Fix(VELOCITY_X); -NODES[6609].Fix(VELOCITY_Y); -NODES[6609].Fix(VELOCITY_Z); -NODES[6610].Fix(VELOCITY_X); -NODES[6610].Fix(VELOCITY_Y); -NODES[6610].Fix(VELOCITY_Z); -NODES[6620].Fix(VELOCITY_X); -NODES[6620].Fix(VELOCITY_Y); -NODES[6620].Fix(VELOCITY_Z); -NODES[6621].Fix(VELOCITY_X); -NODES[6621].Fix(VELOCITY_Y); -NODES[6621].Fix(VELOCITY_Z); -NODES[6622].Fix(VELOCITY_X); -NODES[6622].Fix(VELOCITY_Y); -NODES[6622].Fix(VELOCITY_Z); -NODES[6623].Fix(VELOCITY_X); -NODES[6623].Fix(VELOCITY_Y); -NODES[6623].Fix(VELOCITY_Z); -NODES[6632].Fix(VELOCITY_X); -NODES[6632].Fix(VELOCITY_Y); -NODES[6632].Fix(VELOCITY_Z); -NODES[6635].Fix(VELOCITY_X); -NODES[6635].Fix(VELOCITY_Y); -NODES[6635].Fix(VELOCITY_Z); -NODES[6640].Fix(VELOCITY_X); -NODES[6640].Fix(VELOCITY_Y); -NODES[6640].Fix(VELOCITY_Z); -NODES[6648].Fix(VELOCITY_X); -NODES[6648].Fix(VELOCITY_Y); -NODES[6648].Fix(VELOCITY_Z); -NODES[6649].Fix(VELOCITY_X); -NODES[6649].Fix(VELOCITY_Y); -NODES[6649].Fix(VELOCITY_Z); -NODES[6651].Fix(VELOCITY_X); -NODES[6651].Fix(VELOCITY_Y); -NODES[6651].Fix(VELOCITY_Z); -NODES[6658].Fix(VELOCITY_X); -NODES[6658].Fix(VELOCITY_Y); -NODES[6658].Fix(VELOCITY_Z); -NODES[6663].Fix(VELOCITY_X); -NODES[6663].Fix(VELOCITY_Y); -NODES[6663].Fix(VELOCITY_Z); -NODES[6665].Fix(VELOCITY_X); -NODES[6665].Fix(VELOCITY_Y); -NODES[6665].Fix(VELOCITY_Z); -NODES[6666].Fix(VELOCITY_X); -NODES[6666].Fix(VELOCITY_Y); -NODES[6666].Fix(VELOCITY_Z); -NODES[6673].Fix(VELOCITY_X); -NODES[6673].Fix(VELOCITY_Y); -NODES[6673].Fix(VELOCITY_Z); -NODES[6674].Fix(VELOCITY_X); -NODES[6674].Fix(VELOCITY_Y); -NODES[6674].Fix(VELOCITY_Z); -NODES[6681].Fix(VELOCITY_X); -NODES[6681].Fix(VELOCITY_Y); -NODES[6681].Fix(VELOCITY_Z); -NODES[6683].Fix(VELOCITY_X); -NODES[6683].Fix(VELOCITY_Y); -NODES[6683].Fix(VELOCITY_Z); -NODES[6684].Fix(VELOCITY_X); -NODES[6684].Fix(VELOCITY_Y); -NODES[6684].Fix(VELOCITY_Z); -NODES[6685].Fix(VELOCITY_X); -NODES[6685].Fix(VELOCITY_Y); -NODES[6685].Fix(VELOCITY_Z); -NODES[6686].Fix(VELOCITY_X); -NODES[6686].Fix(VELOCITY_Y); -NODES[6686].Fix(VELOCITY_Z); -NODES[6687].Fix(VELOCITY_X); -NODES[6687].Fix(VELOCITY_Y); -NODES[6687].Fix(VELOCITY_Z); -NODES[6695].Fix(VELOCITY_X); -NODES[6695].Fix(VELOCITY_Y); -NODES[6695].Fix(VELOCITY_Z); -NODES[6699].Fix(VELOCITY_X); -NODES[6699].Fix(VELOCITY_Y); -NODES[6699].Fix(VELOCITY_Z); -NODES[6700].Fix(VELOCITY_X); -NODES[6700].Fix(VELOCITY_Y); -NODES[6700].Fix(VELOCITY_Z); -NODES[6701].Fix(VELOCITY_X); -NODES[6701].Fix(VELOCITY_Y); -NODES[6701].Fix(VELOCITY_Z); -NODES[6702].Fix(VELOCITY_X); -NODES[6702].Fix(VELOCITY_Y); -NODES[6702].Fix(VELOCITY_Z); -NODES[6703].Fix(VELOCITY_X); -NODES[6703].Fix(VELOCITY_Y); -NODES[6703].Fix(VELOCITY_Z); -NODES[6704].Fix(VELOCITY_X); -NODES[6704].Fix(VELOCITY_Y); -NODES[6704].Fix(VELOCITY_Z); -NODES[6705].Fix(VELOCITY_X); -NODES[6705].Fix(VELOCITY_Y); -NODES[6705].Fix(VELOCITY_Z); -NODES[6712].Fix(VELOCITY_X); -NODES[6712].Fix(VELOCITY_Y); -NODES[6712].Fix(VELOCITY_Z); -NODES[6716].Fix(VELOCITY_X); -NODES[6716].Fix(VELOCITY_Y); -NODES[6716].Fix(VELOCITY_Z); -NODES[6717].Fix(VELOCITY_X); -NODES[6717].Fix(VELOCITY_Y); -NODES[6717].Fix(VELOCITY_Z); -NODES[6727].Fix(VELOCITY_X); -NODES[6727].Fix(VELOCITY_Y); -NODES[6727].Fix(VELOCITY_Z); -NODES[6731].Fix(VELOCITY_X); -NODES[6731].Fix(VELOCITY_Y); -NODES[6731].Fix(VELOCITY_Z); -NODES[6732].Fix(VELOCITY_X); -NODES[6732].Fix(VELOCITY_Y); -NODES[6732].Fix(VELOCITY_Z); -NODES[6733].Fix(VELOCITY_X); -NODES[6733].Fix(VELOCITY_Y); -NODES[6733].Fix(VELOCITY_Z); -NODES[6734].Fix(VELOCITY_X); -NODES[6734].Fix(VELOCITY_Y); -NODES[6734].Fix(VELOCITY_Z); -NODES[6735].Fix(VELOCITY_X); -NODES[6735].Fix(VELOCITY_Y); -NODES[6735].Fix(VELOCITY_Z); -NODES[6743].Fix(VELOCITY_X); -NODES[6743].Fix(VELOCITY_Y); -NODES[6743].Fix(VELOCITY_Z); -NODES[6752].Fix(VELOCITY_X); -NODES[6752].Fix(VELOCITY_Y); -NODES[6752].Fix(VELOCITY_Z); -NODES[6753].Fix(VELOCITY_X); -NODES[6753].Fix(VELOCITY_Y); -NODES[6753].Fix(VELOCITY_Z); -NODES[6760].Fix(VELOCITY_X); -NODES[6760].Fix(VELOCITY_Y); -NODES[6760].Fix(VELOCITY_Z); -NODES[6769].Fix(VELOCITY_X); -NODES[6769].Fix(VELOCITY_Y); -NODES[6769].Fix(VELOCITY_Z); -NODES[6774].Fix(VELOCITY_X); -NODES[6774].Fix(VELOCITY_Y); -NODES[6774].Fix(VELOCITY_Z); -NODES[6775].Fix(VELOCITY_X); -NODES[6775].Fix(VELOCITY_Y); -NODES[6775].Fix(VELOCITY_Z); -NODES[6782].Fix(VELOCITY_X); -NODES[6782].Fix(VELOCITY_Y); -NODES[6782].Fix(VELOCITY_Z); -NODES[6783].Fix(VELOCITY_X); -NODES[6783].Fix(VELOCITY_Y); -NODES[6783].Fix(VELOCITY_Z); -NODES[6784].Fix(VELOCITY_X); -NODES[6784].Fix(VELOCITY_Y); -NODES[6784].Fix(VELOCITY_Z); -NODES[6785].Fix(VELOCITY_X); -NODES[6785].Fix(VELOCITY_Y); -NODES[6785].Fix(VELOCITY_Z); -NODES[6786].Fix(VELOCITY_X); -NODES[6786].Fix(VELOCITY_Y); -NODES[6786].Fix(VELOCITY_Z); -NODES[6787].Fix(VELOCITY_X); -NODES[6787].Fix(VELOCITY_Y); -NODES[6787].Fix(VELOCITY_Z); -NODES[6820].Fix(VELOCITY_X); -NODES[6820].Fix(VELOCITY_Y); -NODES[6820].Fix(VELOCITY_Z); -NODES[6827].Fix(VELOCITY_X); -NODES[6827].Fix(VELOCITY_Y); -NODES[6827].Fix(VELOCITY_Z); -NODES[6831].Fix(VELOCITY_X); -NODES[6831].Fix(VELOCITY_Y); -NODES[6831].Fix(VELOCITY_Z); -NODES[6833].Fix(VELOCITY_X); -NODES[6833].Fix(VELOCITY_Y); -NODES[6833].Fix(VELOCITY_Z); -NODES[6834].Fix(VELOCITY_X); -NODES[6834].Fix(VELOCITY_Y); -NODES[6834].Fix(VELOCITY_Z); -NODES[6837].Fix(VELOCITY_X); -NODES[6837].Fix(VELOCITY_Y); -NODES[6837].Fix(VELOCITY_Z); -NODES[6840].Fix(VELOCITY_X); -NODES[6840].Fix(VELOCITY_Y); -NODES[6840].Fix(VELOCITY_Z); -NODES[6843].Fix(VELOCITY_X); -NODES[6843].Fix(VELOCITY_Y); -NODES[6843].Fix(VELOCITY_Z); -NODES[6844].Fix(VELOCITY_X); -NODES[6844].Fix(VELOCITY_Y); -NODES[6844].Fix(VELOCITY_Z); -NODES[6845].Fix(VELOCITY_X); -NODES[6845].Fix(VELOCITY_Y); -NODES[6845].Fix(VELOCITY_Z); -NODES[6846].Fix(VELOCITY_X); -NODES[6846].Fix(VELOCITY_Y); -NODES[6846].Fix(VELOCITY_Z); -NODES[6847].Fix(VELOCITY_X); -NODES[6847].Fix(VELOCITY_Y); -NODES[6847].Fix(VELOCITY_Z); -NODES[6848].Fix(VELOCITY_X); -NODES[6848].Fix(VELOCITY_Y); -NODES[6848].Fix(VELOCITY_Z); -NODES[6849].Fix(VELOCITY_X); -NODES[6849].Fix(VELOCITY_Y); -NODES[6849].Fix(VELOCITY_Z); -NODES[6850].Fix(VELOCITY_X); -NODES[6850].Fix(VELOCITY_Y); -NODES[6850].Fix(VELOCITY_Z); -NODES[6851].Fix(VELOCITY_X); -NODES[6851].Fix(VELOCITY_Y); -NODES[6851].Fix(VELOCITY_Z); -NODES[6852].Fix(VELOCITY_X); -NODES[6852].Fix(VELOCITY_Y); -NODES[6852].Fix(VELOCITY_Z); -NODES[6857].Fix(VELOCITY_X); -NODES[6857].Fix(VELOCITY_Y); -NODES[6857].Fix(VELOCITY_Z); -NODES[6858].Fix(VELOCITY_X); -NODES[6858].Fix(VELOCITY_Y); -NODES[6858].Fix(VELOCITY_Z); -NODES[6865].Fix(VELOCITY_X); -NODES[6865].Fix(VELOCITY_Y); -NODES[6865].Fix(VELOCITY_Z); -NODES[6866].Fix(VELOCITY_X); -NODES[6866].Fix(VELOCITY_Y); -NODES[6866].Fix(VELOCITY_Z); -NODES[6870].Fix(VELOCITY_X); -NODES[6870].Fix(VELOCITY_Y); -NODES[6870].Fix(VELOCITY_Z); -NODES[6876].Fix(VELOCITY_X); -NODES[6876].Fix(VELOCITY_Y); -NODES[6876].Fix(VELOCITY_Z); -NODES[6877].Fix(VELOCITY_X); -NODES[6877].Fix(VELOCITY_Y); -NODES[6877].Fix(VELOCITY_Z); -NODES[6880].Fix(VELOCITY_X); -NODES[6880].Fix(VELOCITY_Y); -NODES[6880].Fix(VELOCITY_Z); -NODES[6881].Fix(VELOCITY_X); -NODES[6881].Fix(VELOCITY_Y); -NODES[6881].Fix(VELOCITY_Z); -NODES[6882].Fix(VELOCITY_X); -NODES[6882].Fix(VELOCITY_Y); -NODES[6882].Fix(VELOCITY_Z); -NODES[6883].Fix(VELOCITY_X); -NODES[6883].Fix(VELOCITY_Y); -NODES[6883].Fix(VELOCITY_Z); -NODES[6884].Fix(VELOCITY_X); -NODES[6884].Fix(VELOCITY_Y); -NODES[6884].Fix(VELOCITY_Z); -NODES[6903].Fix(VELOCITY_X); -NODES[6903].Fix(VELOCITY_Y); -NODES[6903].Fix(VELOCITY_Z); -NODES[6907].Fix(VELOCITY_X); -NODES[6907].Fix(VELOCITY_Y); -NODES[6907].Fix(VELOCITY_Z); -NODES[6913].Fix(VELOCITY_X); -NODES[6913].Fix(VELOCITY_Y); -NODES[6913].Fix(VELOCITY_Z); -NODES[6922].Fix(VELOCITY_X); -NODES[6922].Fix(VELOCITY_Y); -NODES[6922].Fix(VELOCITY_Z); -NODES[6929].Fix(VELOCITY_X); -NODES[6929].Fix(VELOCITY_Y); -NODES[6929].Fix(VELOCITY_Z); -NODES[6930].Fix(VELOCITY_X); -NODES[6930].Fix(VELOCITY_Y); -NODES[6930].Fix(VELOCITY_Z); -NODES[6931].Fix(VELOCITY_X); -NODES[6931].Fix(VELOCITY_Y); -NODES[6931].Fix(VELOCITY_Z); -NODES[6932].Fix(VELOCITY_X); -NODES[6932].Fix(VELOCITY_Y); -NODES[6932].Fix(VELOCITY_Z); -NODES[6948].Fix(VELOCITY_X); -NODES[6948].Fix(VELOCITY_Y); -NODES[6948].Fix(VELOCITY_Z); -NODES[6961].Fix(VELOCITY_X); -NODES[6961].Fix(VELOCITY_Y); -NODES[6961].Fix(VELOCITY_Z); -NODES[6962].Fix(VELOCITY_X); -NODES[6962].Fix(VELOCITY_Y); -NODES[6962].Fix(VELOCITY_Z); -NODES[6963].Fix(VELOCITY_X); -NODES[6963].Fix(VELOCITY_Y); -NODES[6963].Fix(VELOCITY_Z); -NODES[6972].Fix(VELOCITY_X); -NODES[6972].Fix(VELOCITY_Y); -NODES[6972].Fix(VELOCITY_Z); -NODES[6973].Fix(VELOCITY_X); -NODES[6973].Fix(VELOCITY_Y); -NODES[6973].Fix(VELOCITY_Z); -NODES[6974].Fix(VELOCITY_X); -NODES[6974].Fix(VELOCITY_Y); -NODES[6974].Fix(VELOCITY_Z); -NODES[6975].Fix(VELOCITY_X); -NODES[6975].Fix(VELOCITY_Y); -NODES[6975].Fix(VELOCITY_Z); -NODES[6983].Fix(VELOCITY_X); -NODES[6983].Fix(VELOCITY_Y); -NODES[6983].Fix(VELOCITY_Z); -NODES[6990].Fix(VELOCITY_X); -NODES[6990].Fix(VELOCITY_Y); -NODES[6990].Fix(VELOCITY_Z); -NODES[6996].Fix(VELOCITY_X); -NODES[6996].Fix(VELOCITY_Y); -NODES[6996].Fix(VELOCITY_Z); -NODES[7001].Fix(VELOCITY_X); -NODES[7001].Fix(VELOCITY_Y); -NODES[7001].Fix(VELOCITY_Z); -NODES[7002].Fix(VELOCITY_X); -NODES[7002].Fix(VELOCITY_Y); -NODES[7002].Fix(VELOCITY_Z); -NODES[7003].Fix(VELOCITY_X); -NODES[7003].Fix(VELOCITY_Y); -NODES[7003].Fix(VELOCITY_Z); -NODES[7004].Fix(VELOCITY_X); -NODES[7004].Fix(VELOCITY_Y); -NODES[7004].Fix(VELOCITY_Z); -NODES[7006].Fix(VELOCITY_X); -NODES[7006].Fix(VELOCITY_Y); -NODES[7006].Fix(VELOCITY_Z); -NODES[7008].Fix(VELOCITY_X); -NODES[7008].Fix(VELOCITY_Y); -NODES[7008].Fix(VELOCITY_Z); -NODES[7009].Fix(VELOCITY_X); -NODES[7009].Fix(VELOCITY_Y); -NODES[7009].Fix(VELOCITY_Z); -NODES[7012].Fix(VELOCITY_X); -NODES[7012].Fix(VELOCITY_Y); -NODES[7012].Fix(VELOCITY_Z); -NODES[7017].Fix(VELOCITY_X); -NODES[7017].Fix(VELOCITY_Y); -NODES[7017].Fix(VELOCITY_Z); -NODES[7018].Fix(VELOCITY_X); -NODES[7018].Fix(VELOCITY_Y); -NODES[7018].Fix(VELOCITY_Z); -NODES[7019].Fix(VELOCITY_X); -NODES[7019].Fix(VELOCITY_Y); -NODES[7019].Fix(VELOCITY_Z); -NODES[7020].Fix(VELOCITY_X); -NODES[7020].Fix(VELOCITY_Y); -NODES[7020].Fix(VELOCITY_Z); -NODES[7021].Fix(VELOCITY_X); -NODES[7021].Fix(VELOCITY_Y); -NODES[7021].Fix(VELOCITY_Z); -NODES[7029].Fix(VELOCITY_X); -NODES[7029].Fix(VELOCITY_Y); -NODES[7029].Fix(VELOCITY_Z); -NODES[7033].Fix(VELOCITY_X); -NODES[7033].Fix(VELOCITY_Y); -NODES[7033].Fix(VELOCITY_Z); -NODES[7039].Fix(VELOCITY_X); -NODES[7039].Fix(VELOCITY_Y); -NODES[7039].Fix(VELOCITY_Z); -NODES[7044].Fix(VELOCITY_X); -NODES[7044].Fix(VELOCITY_Y); -NODES[7044].Fix(VELOCITY_Z); -NODES[7045].Fix(VELOCITY_X); -NODES[7045].Fix(VELOCITY_Y); -NODES[7045].Fix(VELOCITY_Z); -NODES[7046].Fix(VELOCITY_X); -NODES[7046].Fix(VELOCITY_Y); -NODES[7046].Fix(VELOCITY_Z); -NODES[7047].Fix(VELOCITY_X); -NODES[7047].Fix(VELOCITY_Y); -NODES[7047].Fix(VELOCITY_Z); -NODES[7048].Fix(VELOCITY_X); -NODES[7048].Fix(VELOCITY_Y); -NODES[7048].Fix(VELOCITY_Z); -NODES[7049].Fix(VELOCITY_X); -NODES[7049].Fix(VELOCITY_Y); -NODES[7049].Fix(VELOCITY_Z); -NODES[7060].Fix(VELOCITY_X); -NODES[7060].Fix(VELOCITY_Y); -NODES[7060].Fix(VELOCITY_Z); -NODES[7066].Fix(VELOCITY_X); -NODES[7066].Fix(VELOCITY_Y); -NODES[7066].Fix(VELOCITY_Z); -NODES[7070].Fix(VELOCITY_X); -NODES[7070].Fix(VELOCITY_Y); -NODES[7070].Fix(VELOCITY_Z); -NODES[7075].Fix(VELOCITY_X); -NODES[7075].Fix(VELOCITY_Y); -NODES[7075].Fix(VELOCITY_Z); -NODES[7080].Fix(VELOCITY_X); -NODES[7080].Fix(VELOCITY_Y); -NODES[7080].Fix(VELOCITY_Z); -NODES[7083].Fix(VELOCITY_X); -NODES[7083].Fix(VELOCITY_Y); -NODES[7083].Fix(VELOCITY_Z); -NODES[7084].Fix(VELOCITY_X); -NODES[7084].Fix(VELOCITY_Y); -NODES[7084].Fix(VELOCITY_Z); -NODES[7099].Fix(VELOCITY_X); -NODES[7099].Fix(VELOCITY_Y); -NODES[7099].Fix(VELOCITY_Z); -NODES[7100].Fix(VELOCITY_X); -NODES[7100].Fix(VELOCITY_Y); -NODES[7100].Fix(VELOCITY_Z); -NODES[7101].Fix(VELOCITY_X); -NODES[7101].Fix(VELOCITY_Y); -NODES[7101].Fix(VELOCITY_Z); -NODES[7102].Fix(VELOCITY_X); -NODES[7102].Fix(VELOCITY_Y); -NODES[7102].Fix(VELOCITY_Z); -NODES[7103].Fix(VELOCITY_X); -NODES[7103].Fix(VELOCITY_Y); -NODES[7103].Fix(VELOCITY_Z); -NODES[7108].Fix(VELOCITY_X); -NODES[7108].Fix(VELOCITY_Y); -NODES[7108].Fix(VELOCITY_Z); -NODES[7125].Fix(VELOCITY_X); -NODES[7125].Fix(VELOCITY_Y); -NODES[7125].Fix(VELOCITY_Z); -NODES[7131].Fix(VELOCITY_X); -NODES[7131].Fix(VELOCITY_Y); -NODES[7131].Fix(VELOCITY_Z); -NODES[7136].Fix(VELOCITY_X); -NODES[7136].Fix(VELOCITY_Y); -NODES[7136].Fix(VELOCITY_Z); -NODES[7137].Fix(VELOCITY_X); -NODES[7137].Fix(VELOCITY_Y); -NODES[7137].Fix(VELOCITY_Z); -NODES[7138].Fix(VELOCITY_X); -NODES[7138].Fix(VELOCITY_Y); -NODES[7138].Fix(VELOCITY_Z); -NODES[7144].Fix(VELOCITY_X); -NODES[7144].Fix(VELOCITY_Y); -NODES[7144].Fix(VELOCITY_Z); -NODES[7145].Fix(VELOCITY_X); -NODES[7145].Fix(VELOCITY_Y); -NODES[7145].Fix(VELOCITY_Z); -NODES[7160].Fix(VELOCITY_X); -NODES[7160].Fix(VELOCITY_Y); -NODES[7160].Fix(VELOCITY_Z); -NODES[7162].Fix(VELOCITY_X); -NODES[7162].Fix(VELOCITY_Y); -NODES[7162].Fix(VELOCITY_Z); -NODES[7168].Fix(VELOCITY_X); -NODES[7168].Fix(VELOCITY_Y); -NODES[7168].Fix(VELOCITY_Z); -NODES[7173].Fix(VELOCITY_X); -NODES[7173].Fix(VELOCITY_Y); -NODES[7173].Fix(VELOCITY_Z); -NODES[7174].Fix(VELOCITY_X); -NODES[7174].Fix(VELOCITY_Y); -NODES[7174].Fix(VELOCITY_Z); -NODES[7175].Fix(VELOCITY_X); -NODES[7175].Fix(VELOCITY_Y); -NODES[7175].Fix(VELOCITY_Z); -NODES[7176].Fix(VELOCITY_X); -NODES[7176].Fix(VELOCITY_Y); -NODES[7176].Fix(VELOCITY_Z); -NODES[7177].Fix(VELOCITY_X); -NODES[7177].Fix(VELOCITY_Y); -NODES[7177].Fix(VELOCITY_Z); -NODES[7179].Fix(VELOCITY_X); -NODES[7179].Fix(VELOCITY_Y); -NODES[7179].Fix(VELOCITY_Z); -NODES[7183].Fix(VELOCITY_X); -NODES[7183].Fix(VELOCITY_Y); -NODES[7183].Fix(VELOCITY_Z); -NODES[7186].Fix(VELOCITY_X); -NODES[7186].Fix(VELOCITY_Y); -NODES[7186].Fix(VELOCITY_Z); -NODES[7187].Fix(VELOCITY_X); -NODES[7187].Fix(VELOCITY_Y); -NODES[7187].Fix(VELOCITY_Z); -NODES[7203].Fix(VELOCITY_X); -NODES[7203].Fix(VELOCITY_Y); -NODES[7203].Fix(VELOCITY_Z); -NODES[7204].Fix(VELOCITY_X); -NODES[7204].Fix(VELOCITY_Y); -NODES[7204].Fix(VELOCITY_Z); -NODES[7205].Fix(VELOCITY_X); -NODES[7205].Fix(VELOCITY_Y); -NODES[7205].Fix(VELOCITY_Z); -NODES[7206].Fix(VELOCITY_X); -NODES[7206].Fix(VELOCITY_Y); -NODES[7206].Fix(VELOCITY_Z); -NODES[7207].Fix(VELOCITY_X); -NODES[7207].Fix(VELOCITY_Y); -NODES[7207].Fix(VELOCITY_Z); -NODES[7229].Fix(VELOCITY_X); -NODES[7229].Fix(VELOCITY_Y); -NODES[7229].Fix(VELOCITY_Z); -NODES[7232].Fix(VELOCITY_X); -NODES[7232].Fix(VELOCITY_Y); -NODES[7232].Fix(VELOCITY_Z); -NODES[7239].Fix(VELOCITY_X); -NODES[7239].Fix(VELOCITY_Y); -NODES[7239].Fix(VELOCITY_Z); -NODES[7245].Fix(VELOCITY_X); -NODES[7245].Fix(VELOCITY_Y); -NODES[7245].Fix(VELOCITY_Z); -NODES[7246].Fix(VELOCITY_X); -NODES[7246].Fix(VELOCITY_Y); -NODES[7246].Fix(VELOCITY_Z); -NODES[7247].Fix(VELOCITY_X); -NODES[7247].Fix(VELOCITY_Y); -NODES[7247].Fix(VELOCITY_Z); -NODES[7248].Fix(VELOCITY_X); -NODES[7248].Fix(VELOCITY_Y); -NODES[7248].Fix(VELOCITY_Z); -NODES[7251].Fix(VELOCITY_X); -NODES[7251].Fix(VELOCITY_Y); -NODES[7251].Fix(VELOCITY_Z); -NODES[7255].Fix(VELOCITY_X); -NODES[7255].Fix(VELOCITY_Y); -NODES[7255].Fix(VELOCITY_Z); -NODES[7256].Fix(VELOCITY_X); -NODES[7256].Fix(VELOCITY_Y); -NODES[7256].Fix(VELOCITY_Z); -NODES[7261].Fix(VELOCITY_X); -NODES[7261].Fix(VELOCITY_Y); -NODES[7261].Fix(VELOCITY_Z); -NODES[7276].Fix(VELOCITY_X); -NODES[7276].Fix(VELOCITY_Y); -NODES[7276].Fix(VELOCITY_Z); -NODES[7281].Fix(VELOCITY_X); -NODES[7281].Fix(VELOCITY_Y); -NODES[7281].Fix(VELOCITY_Z); -NODES[7282].Fix(VELOCITY_X); -NODES[7282].Fix(VELOCITY_Y); -NODES[7282].Fix(VELOCITY_Z); -NODES[7301].Fix(VELOCITY_X); -NODES[7301].Fix(VELOCITY_Y); -NODES[7301].Fix(VELOCITY_Z); -NODES[7321].Fix(VELOCITY_X); -NODES[7321].Fix(VELOCITY_Y); -NODES[7321].Fix(VELOCITY_Z); -NODES[7322].Fix(VELOCITY_X); -NODES[7322].Fix(VELOCITY_Y); -NODES[7322].Fix(VELOCITY_Z); -NODES[7323].Fix(VELOCITY_X); -NODES[7323].Fix(VELOCITY_Y); -NODES[7323].Fix(VELOCITY_Z); -NODES[7324].Fix(VELOCITY_X); -NODES[7324].Fix(VELOCITY_Y); -NODES[7324].Fix(VELOCITY_Z); -NODES[7325].Fix(VELOCITY_X); -NODES[7325].Fix(VELOCITY_Y); -NODES[7325].Fix(VELOCITY_Z); -NODES[7327].Fix(VELOCITY_X); -NODES[7327].Fix(VELOCITY_Y); -NODES[7327].Fix(VELOCITY_Z); -NODES[7331].Fix(VELOCITY_X); -NODES[7331].Fix(VELOCITY_Y); -NODES[7331].Fix(VELOCITY_Z); -NODES[7334].Fix(VELOCITY_X); -NODES[7334].Fix(VELOCITY_Y); -NODES[7334].Fix(VELOCITY_Z); -NODES[7335].Fix(VELOCITY_X); -NODES[7335].Fix(VELOCITY_Y); -NODES[7335].Fix(VELOCITY_Z); -NODES[7338].Fix(VELOCITY_X); -NODES[7338].Fix(VELOCITY_Y); -NODES[7338].Fix(VELOCITY_Z); -NODES[7345].Fix(VELOCITY_X); -NODES[7345].Fix(VELOCITY_Y); -NODES[7345].Fix(VELOCITY_Z); -NODES[7349].Fix(VELOCITY_X); -NODES[7349].Fix(VELOCITY_Y); -NODES[7349].Fix(VELOCITY_Z); -NODES[7350].Fix(VELOCITY_X); -NODES[7350].Fix(VELOCITY_Y); -NODES[7350].Fix(VELOCITY_Z); -NODES[7361].Fix(VELOCITY_X); -NODES[7361].Fix(VELOCITY_Y); -NODES[7361].Fix(VELOCITY_Z); -NODES[7366].Fix(VELOCITY_X); -NODES[7366].Fix(VELOCITY_Y); -NODES[7366].Fix(VELOCITY_Z); -NODES[7369].Fix(VELOCITY_X); -NODES[7369].Fix(VELOCITY_Y); -NODES[7369].Fix(VELOCITY_Z); -NODES[7370].Fix(VELOCITY_X); -NODES[7370].Fix(VELOCITY_Y); -NODES[7370].Fix(VELOCITY_Z); -NODES[7380].Fix(VELOCITY_X); -NODES[7380].Fix(VELOCITY_Y); -NODES[7380].Fix(VELOCITY_Z); -NODES[7383].Fix(VELOCITY_X); -NODES[7383].Fix(VELOCITY_Y); -NODES[7383].Fix(VELOCITY_Z); -NODES[7384].Fix(VELOCITY_X); -NODES[7384].Fix(VELOCITY_Y); -NODES[7384].Fix(VELOCITY_Z); -NODES[7386].Fix(VELOCITY_X); -NODES[7386].Fix(VELOCITY_Y); -NODES[7386].Fix(VELOCITY_Z); -NODES[7388].Fix(VELOCITY_X); -NODES[7388].Fix(VELOCITY_Y); -NODES[7388].Fix(VELOCITY_Z); -NODES[7389].Fix(VELOCITY_X); -NODES[7389].Fix(VELOCITY_Y); -NODES[7389].Fix(VELOCITY_Z); -NODES[7394].Fix(VELOCITY_X); -NODES[7394].Fix(VELOCITY_Y); -NODES[7394].Fix(VELOCITY_Z); -NODES[7397].Fix(VELOCITY_X); -NODES[7397].Fix(VELOCITY_Y); -NODES[7397].Fix(VELOCITY_Z); -NODES[7398].Fix(VELOCITY_X); -NODES[7398].Fix(VELOCITY_Y); -NODES[7398].Fix(VELOCITY_Z); -NODES[7399].Fix(VELOCITY_X); -NODES[7399].Fix(VELOCITY_Y); -NODES[7399].Fix(VELOCITY_Z); -NODES[7400].Fix(VELOCITY_X); -NODES[7400].Fix(VELOCITY_Y); -NODES[7400].Fix(VELOCITY_Z); -NODES[7404].Fix(VELOCITY_X); -NODES[7404].Fix(VELOCITY_Y); -NODES[7404].Fix(VELOCITY_Z); -NODES[7405].Fix(VELOCITY_X); -NODES[7405].Fix(VELOCITY_Y); -NODES[7405].Fix(VELOCITY_Z); -NODES[7412].Fix(VELOCITY_X); -NODES[7412].Fix(VELOCITY_Y); -NODES[7412].Fix(VELOCITY_Z); -NODES[7414].Fix(VELOCITY_X); -NODES[7414].Fix(VELOCITY_Y); -NODES[7414].Fix(VELOCITY_Z); -NODES[7415].Fix(VELOCITY_X); -NODES[7415].Fix(VELOCITY_Y); -NODES[7415].Fix(VELOCITY_Z); -NODES[7423].Fix(VELOCITY_X); -NODES[7423].Fix(VELOCITY_Y); -NODES[7423].Fix(VELOCITY_Z); -NODES[7430].Fix(VELOCITY_X); -NODES[7430].Fix(VELOCITY_Y); -NODES[7430].Fix(VELOCITY_Z); -NODES[7434].Fix(VELOCITY_X); -NODES[7434].Fix(VELOCITY_Y); -NODES[7434].Fix(VELOCITY_Z); -NODES[7435].Fix(VELOCITY_X); -NODES[7435].Fix(VELOCITY_Y); -NODES[7435].Fix(VELOCITY_Z); -NODES[7436].Fix(VELOCITY_X); -NODES[7436].Fix(VELOCITY_Y); -NODES[7436].Fix(VELOCITY_Z); -NODES[7437].Fix(VELOCITY_X); -NODES[7437].Fix(VELOCITY_Y); -NODES[7437].Fix(VELOCITY_Z); -NODES[7438].Fix(VELOCITY_X); -NODES[7438].Fix(VELOCITY_Y); -NODES[7438].Fix(VELOCITY_Z); -NODES[7439].Fix(VELOCITY_X); -NODES[7439].Fix(VELOCITY_Y); -NODES[7439].Fix(VELOCITY_Z); -NODES[7440].Fix(VELOCITY_X); -NODES[7440].Fix(VELOCITY_Y); -NODES[7440].Fix(VELOCITY_Z); -NODES[7441].Fix(VELOCITY_X); -NODES[7441].Fix(VELOCITY_Y); -NODES[7441].Fix(VELOCITY_Z); -NODES[7444].Fix(VELOCITY_X); -NODES[7444].Fix(VELOCITY_Y); -NODES[7444].Fix(VELOCITY_Z); -NODES[7449].Fix(VELOCITY_X); -NODES[7449].Fix(VELOCITY_Y); -NODES[7449].Fix(VELOCITY_Z); -NODES[7453].Fix(VELOCITY_X); -NODES[7453].Fix(VELOCITY_Y); -NODES[7453].Fix(VELOCITY_Z); -NODES[7455].Fix(VELOCITY_X); -NODES[7455].Fix(VELOCITY_Y); -NODES[7455].Fix(VELOCITY_Z); -NODES[7462].Fix(VELOCITY_X); -NODES[7462].Fix(VELOCITY_Y); -NODES[7462].Fix(VELOCITY_Z); -NODES[7463].Fix(VELOCITY_X); -NODES[7463].Fix(VELOCITY_Y); -NODES[7463].Fix(VELOCITY_Z); -NODES[7464].Fix(VELOCITY_X); -NODES[7464].Fix(VELOCITY_Y); -NODES[7464].Fix(VELOCITY_Z); -NODES[7469].Fix(VELOCITY_X); -NODES[7469].Fix(VELOCITY_Y); -NODES[7469].Fix(VELOCITY_Z); -NODES[7473].Fix(VELOCITY_X); -NODES[7473].Fix(VELOCITY_Y); -NODES[7473].Fix(VELOCITY_Z); -NODES[7474].Fix(VELOCITY_X); -NODES[7474].Fix(VELOCITY_Y); -NODES[7474].Fix(VELOCITY_Z); -NODES[7476].Fix(VELOCITY_X); -NODES[7476].Fix(VELOCITY_Y); -NODES[7476].Fix(VELOCITY_Z); -NODES[7479].Fix(VELOCITY_X); -NODES[7479].Fix(VELOCITY_Y); -NODES[7479].Fix(VELOCITY_Z); -NODES[7480].Fix(VELOCITY_X); -NODES[7480].Fix(VELOCITY_Y); -NODES[7480].Fix(VELOCITY_Z); -NODES[7481].Fix(VELOCITY_X); -NODES[7481].Fix(VELOCITY_Y); -NODES[7481].Fix(VELOCITY_Z); -NODES[7503].Fix(VELOCITY_X); -NODES[7503].Fix(VELOCITY_Y); -NODES[7503].Fix(VELOCITY_Z); -NODES[7504].Fix(VELOCITY_X); -NODES[7504].Fix(VELOCITY_Y); -NODES[7504].Fix(VELOCITY_Z); -NODES[7506].Fix(VELOCITY_X); -NODES[7506].Fix(VELOCITY_Y); -NODES[7506].Fix(VELOCITY_Z); -NODES[7518].Fix(VELOCITY_X); -NODES[7518].Fix(VELOCITY_Y); -NODES[7518].Fix(VELOCITY_Z); -NODES[7521].Fix(VELOCITY_X); -NODES[7521].Fix(VELOCITY_Y); -NODES[7521].Fix(VELOCITY_Z); -NODES[7522].Fix(VELOCITY_X); -NODES[7522].Fix(VELOCITY_Y); -NODES[7522].Fix(VELOCITY_Z); -NODES[7527].Fix(VELOCITY_X); -NODES[7527].Fix(VELOCITY_Y); -NODES[7527].Fix(VELOCITY_Z); -NODES[7528].Fix(VELOCITY_X); -NODES[7528].Fix(VELOCITY_Y); -NODES[7528].Fix(VELOCITY_Z); -NODES[7530].Fix(VELOCITY_X); -NODES[7530].Fix(VELOCITY_Y); -NODES[7530].Fix(VELOCITY_Z); -NODES[7531].Fix(VELOCITY_X); -NODES[7531].Fix(VELOCITY_Y); -NODES[7531].Fix(VELOCITY_Z); -NODES[7533].Fix(VELOCITY_X); -NODES[7533].Fix(VELOCITY_Y); -NODES[7533].Fix(VELOCITY_Z); -NODES[7534].Fix(VELOCITY_X); -NODES[7534].Fix(VELOCITY_Y); -NODES[7534].Fix(VELOCITY_Z); -NODES[7546].Fix(VELOCITY_X); -NODES[7546].Fix(VELOCITY_Y); -NODES[7546].Fix(VELOCITY_Z); -NODES[7547].Fix(VELOCITY_X); -NODES[7547].Fix(VELOCITY_Y); -NODES[7547].Fix(VELOCITY_Z); -NODES[7548].Fix(VELOCITY_X); -NODES[7548].Fix(VELOCITY_Y); -NODES[7548].Fix(VELOCITY_Z); -NODES[7549].Fix(VELOCITY_X); -NODES[7549].Fix(VELOCITY_Y); -NODES[7549].Fix(VELOCITY_Z); -NODES[7552].Fix(VELOCITY_X); -NODES[7552].Fix(VELOCITY_Y); -NODES[7552].Fix(VELOCITY_Z); -NODES[7561].Fix(VELOCITY_X); -NODES[7561].Fix(VELOCITY_Y); -NODES[7561].Fix(VELOCITY_Z); -NODES[7562].Fix(VELOCITY_X); -NODES[7562].Fix(VELOCITY_Y); -NODES[7562].Fix(VELOCITY_Z); -NODES[7563].Fix(VELOCITY_X); -NODES[7563].Fix(VELOCITY_Y); -NODES[7563].Fix(VELOCITY_Z); -NODES[7564].Fix(VELOCITY_X); -NODES[7564].Fix(VELOCITY_Y); -NODES[7564].Fix(VELOCITY_Z); -NODES[7565].Fix(VELOCITY_X); -NODES[7565].Fix(VELOCITY_Y); -NODES[7565].Fix(VELOCITY_Z); -NODES[7570].Fix(VELOCITY_X); -NODES[7570].Fix(VELOCITY_Y); -NODES[7570].Fix(VELOCITY_Z); -NODES[7575].Fix(VELOCITY_X); -NODES[7575].Fix(VELOCITY_Y); -NODES[7575].Fix(VELOCITY_Z); -NODES[7576].Fix(VELOCITY_X); -NODES[7576].Fix(VELOCITY_Y); -NODES[7576].Fix(VELOCITY_Z); -NODES[7577].Fix(VELOCITY_X); -NODES[7577].Fix(VELOCITY_Y); -NODES[7577].Fix(VELOCITY_Z); -NODES[7592].Fix(VELOCITY_X); -NODES[7592].Fix(VELOCITY_Y); -NODES[7592].Fix(VELOCITY_Z); -NODES[7596].Fix(VELOCITY_X); -NODES[7596].Fix(VELOCITY_Y); -NODES[7596].Fix(VELOCITY_Z); -NODES[7620].Fix(VELOCITY_X); -NODES[7620].Fix(VELOCITY_Y); -NODES[7620].Fix(VELOCITY_Z); -NODES[7625].Fix(VELOCITY_X); -NODES[7625].Fix(VELOCITY_Y); -NODES[7625].Fix(VELOCITY_Z); -NODES[7630].Fix(VELOCITY_X); -NODES[7630].Fix(VELOCITY_Y); -NODES[7630].Fix(VELOCITY_Z); -NODES[7631].Fix(VELOCITY_X); -NODES[7631].Fix(VELOCITY_Y); -NODES[7631].Fix(VELOCITY_Z); -NODES[7636].Fix(VELOCITY_X); -NODES[7636].Fix(VELOCITY_Y); -NODES[7636].Fix(VELOCITY_Z); -NODES[7637].Fix(VELOCITY_X); -NODES[7637].Fix(VELOCITY_Y); -NODES[7637].Fix(VELOCITY_Z); -NODES[7638].Fix(VELOCITY_X); -NODES[7638].Fix(VELOCITY_Y); -NODES[7638].Fix(VELOCITY_Z); -NODES[7642].Fix(VELOCITY_X); -NODES[7642].Fix(VELOCITY_Y); -NODES[7642].Fix(VELOCITY_Z); -NODES[7643].Fix(VELOCITY_X); -NODES[7643].Fix(VELOCITY_Y); -NODES[7643].Fix(VELOCITY_Z); -NODES[7645].Fix(VELOCITY_X); -NODES[7645].Fix(VELOCITY_Y); -NODES[7645].Fix(VELOCITY_Z); -NODES[7646].Fix(VELOCITY_X); -NODES[7646].Fix(VELOCITY_Y); -NODES[7646].Fix(VELOCITY_Z); -NODES[7654].Fix(VELOCITY_X); -NODES[7654].Fix(VELOCITY_Y); -NODES[7654].Fix(VELOCITY_Z); -NODES[7656].Fix(VELOCITY_X); -NODES[7656].Fix(VELOCITY_Y); -NODES[7656].Fix(VELOCITY_Z); -NODES[7660].Fix(VELOCITY_X); -NODES[7660].Fix(VELOCITY_Y); -NODES[7660].Fix(VELOCITY_Z); -NODES[7670].Fix(VELOCITY_X); -NODES[7670].Fix(VELOCITY_Y); -NODES[7670].Fix(VELOCITY_Z); -NODES[7683].Fix(VELOCITY_X); -NODES[7683].Fix(VELOCITY_Y); -NODES[7683].Fix(VELOCITY_Z); -NODES[7684].Fix(VELOCITY_X); -NODES[7684].Fix(VELOCITY_Y); -NODES[7684].Fix(VELOCITY_Z); -NODES[7685].Fix(VELOCITY_X); -NODES[7685].Fix(VELOCITY_Y); -NODES[7685].Fix(VELOCITY_Z); -NODES[7686].Fix(VELOCITY_X); -NODES[7686].Fix(VELOCITY_Y); -NODES[7686].Fix(VELOCITY_Z); -NODES[7687].Fix(VELOCITY_X); -NODES[7687].Fix(VELOCITY_Y); -NODES[7687].Fix(VELOCITY_Z); -NODES[7688].Fix(VELOCITY_X); -NODES[7688].Fix(VELOCITY_Y); -NODES[7688].Fix(VELOCITY_Z); -NODES[7689].Fix(VELOCITY_X); -NODES[7689].Fix(VELOCITY_Y); -NODES[7689].Fix(VELOCITY_Z); -NODES[7694].Fix(VELOCITY_X); -NODES[7694].Fix(VELOCITY_Y); -NODES[7694].Fix(VELOCITY_Z); -NODES[7695].Fix(VELOCITY_X); -NODES[7695].Fix(VELOCITY_Y); -NODES[7695].Fix(VELOCITY_Z); -NODES[7697].Fix(VELOCITY_X); -NODES[7697].Fix(VELOCITY_Y); -NODES[7697].Fix(VELOCITY_Z); -NODES[7700].Fix(VELOCITY_X); -NODES[7700].Fix(VELOCITY_Y); -NODES[7700].Fix(VELOCITY_Z); -NODES[7702].Fix(VELOCITY_X); -NODES[7702].Fix(VELOCITY_Y); -NODES[7702].Fix(VELOCITY_Z); -NODES[7708].Fix(VELOCITY_X); -NODES[7708].Fix(VELOCITY_Y); -NODES[7708].Fix(VELOCITY_Z); -NODES[7709].Fix(VELOCITY_X); -NODES[7709].Fix(VELOCITY_Y); -NODES[7709].Fix(VELOCITY_Z); -NODES[7710].Fix(VELOCITY_X); -NODES[7710].Fix(VELOCITY_Y); -NODES[7710].Fix(VELOCITY_Z); -NODES[7718].Fix(VELOCITY_X); -NODES[7718].Fix(VELOCITY_Y); -NODES[7718].Fix(VELOCITY_Z); -NODES[7729].Fix(VELOCITY_X); -NODES[7729].Fix(VELOCITY_Y); -NODES[7729].Fix(VELOCITY_Z); -NODES[7735].Fix(VELOCITY_X); -NODES[7735].Fix(VELOCITY_Y); -NODES[7735].Fix(VELOCITY_Z); -NODES[7736].Fix(VELOCITY_X); -NODES[7736].Fix(VELOCITY_Y); -NODES[7736].Fix(VELOCITY_Z); -NODES[7738].Fix(VELOCITY_X); -NODES[7738].Fix(VELOCITY_Y); -NODES[7738].Fix(VELOCITY_Z); -NODES[7739].Fix(VELOCITY_X); -NODES[7739].Fix(VELOCITY_Y); -NODES[7739].Fix(VELOCITY_Z); -NODES[7748].Fix(VELOCITY_X); -NODES[7748].Fix(VELOCITY_Y); -NODES[7748].Fix(VELOCITY_Z); -NODES[7751].Fix(VELOCITY_X); -NODES[7751].Fix(VELOCITY_Y); -NODES[7751].Fix(VELOCITY_Z); -NODES[7752].Fix(VELOCITY_X); -NODES[7752].Fix(VELOCITY_Y); -NODES[7752].Fix(VELOCITY_Z); -NODES[7758].Fix(VELOCITY_X); -NODES[7758].Fix(VELOCITY_Y); -NODES[7758].Fix(VELOCITY_Z); -NODES[7759].Fix(VELOCITY_X); -NODES[7759].Fix(VELOCITY_Y); -NODES[7759].Fix(VELOCITY_Z); -NODES[7765].Fix(VELOCITY_X); -NODES[7765].Fix(VELOCITY_Y); -NODES[7765].Fix(VELOCITY_Z); -NODES[7766].Fix(VELOCITY_X); -NODES[7766].Fix(VELOCITY_Y); -NODES[7766].Fix(VELOCITY_Z); -NODES[7770].Fix(VELOCITY_X); -NODES[7770].Fix(VELOCITY_Y); -NODES[7770].Fix(VELOCITY_Z); -NODES[7774].Fix(VELOCITY_X); -NODES[7774].Fix(VELOCITY_Y); -NODES[7774].Fix(VELOCITY_Z); -NODES[7782].Fix(VELOCITY_X); -NODES[7782].Fix(VELOCITY_Y); -NODES[7782].Fix(VELOCITY_Z); -NODES[7792].Fix(VELOCITY_X); -NODES[7792].Fix(VELOCITY_Y); -NODES[7792].Fix(VELOCITY_Z); -NODES[7793].Fix(VELOCITY_X); -NODES[7793].Fix(VELOCITY_Y); -NODES[7793].Fix(VELOCITY_Z); -NODES[7796].Fix(VELOCITY_X); -NODES[7796].Fix(VELOCITY_Y); -NODES[7796].Fix(VELOCITY_Z); -NODES[7797].Fix(VELOCITY_X); -NODES[7797].Fix(VELOCITY_Y); -NODES[7797].Fix(VELOCITY_Z); -NODES[7798].Fix(VELOCITY_X); -NODES[7798].Fix(VELOCITY_Y); -NODES[7798].Fix(VELOCITY_Z); -NODES[7799].Fix(VELOCITY_X); -NODES[7799].Fix(VELOCITY_Y); -NODES[7799].Fix(VELOCITY_Z); -NODES[7800].Fix(VELOCITY_X); -NODES[7800].Fix(VELOCITY_Y); -NODES[7800].Fix(VELOCITY_Z); -NODES[7801].Fix(VELOCITY_X); -NODES[7801].Fix(VELOCITY_Y); -NODES[7801].Fix(VELOCITY_Z); -NODES[7802].Fix(VELOCITY_X); -NODES[7802].Fix(VELOCITY_Y); -NODES[7802].Fix(VELOCITY_Z); -NODES[7816].Fix(VELOCITY_X); -NODES[7816].Fix(VELOCITY_Y); -NODES[7816].Fix(VELOCITY_Z); -NODES[7824].Fix(VELOCITY_X); -NODES[7824].Fix(VELOCITY_Y); -NODES[7824].Fix(VELOCITY_Z); -NODES[7830].Fix(VELOCITY_X); -NODES[7830].Fix(VELOCITY_Y); -NODES[7830].Fix(VELOCITY_Z); -NODES[7834].Fix(VELOCITY_X); -NODES[7834].Fix(VELOCITY_Y); -NODES[7834].Fix(VELOCITY_Z); -NODES[7835].Fix(VELOCITY_X); -NODES[7835].Fix(VELOCITY_Y); -NODES[7835].Fix(VELOCITY_Z); -NODES[7846].Fix(VELOCITY_X); -NODES[7846].Fix(VELOCITY_Y); -NODES[7846].Fix(VELOCITY_Z); -NODES[7857].Fix(VELOCITY_X); -NODES[7857].Fix(VELOCITY_Y); -NODES[7857].Fix(VELOCITY_Z); -NODES[7859].Fix(VELOCITY_X); -NODES[7859].Fix(VELOCITY_Y); -NODES[7859].Fix(VELOCITY_Z); -NODES[7865].Fix(VELOCITY_X); -NODES[7865].Fix(VELOCITY_Y); -NODES[7865].Fix(VELOCITY_Z); -NODES[7876].Fix(VELOCITY_X); -NODES[7876].Fix(VELOCITY_Y); -NODES[7876].Fix(VELOCITY_Z); -NODES[7877].Fix(VELOCITY_X); -NODES[7877].Fix(VELOCITY_Y); -NODES[7877].Fix(VELOCITY_Z); -NODES[7878].Fix(VELOCITY_X); -NODES[7878].Fix(VELOCITY_Y); -NODES[7878].Fix(VELOCITY_Z); -NODES[7879].Fix(VELOCITY_X); -NODES[7879].Fix(VELOCITY_Y); -NODES[7879].Fix(VELOCITY_Z); -NODES[7884].Fix(VELOCITY_X); -NODES[7884].Fix(VELOCITY_Y); -NODES[7884].Fix(VELOCITY_Z); -NODES[7885].Fix(VELOCITY_X); -NODES[7885].Fix(VELOCITY_Y); -NODES[7885].Fix(VELOCITY_Z); -NODES[7891].Fix(VELOCITY_X); -NODES[7891].Fix(VELOCITY_Y); -NODES[7891].Fix(VELOCITY_Z); -NODES[7896].Fix(VELOCITY_X); -NODES[7896].Fix(VELOCITY_Y); -NODES[7896].Fix(VELOCITY_Z); -NODES[7901].Fix(VELOCITY_X); -NODES[7901].Fix(VELOCITY_Y); -NODES[7901].Fix(VELOCITY_Z); -NODES[7902].Fix(VELOCITY_X); -NODES[7902].Fix(VELOCITY_Y); -NODES[7902].Fix(VELOCITY_Z); -NODES[7906].Fix(VELOCITY_X); -NODES[7906].Fix(VELOCITY_Y); -NODES[7906].Fix(VELOCITY_Z); -NODES[7913].Fix(VELOCITY_X); -NODES[7913].Fix(VELOCITY_Y); -NODES[7913].Fix(VELOCITY_Z); -NODES[7915].Fix(VELOCITY_X); -NODES[7915].Fix(VELOCITY_Y); -NODES[7915].Fix(VELOCITY_Z); -NODES[7933].Fix(VELOCITY_X); -NODES[7933].Fix(VELOCITY_Y); -NODES[7933].Fix(VELOCITY_Z); -NODES[7945].Fix(VELOCITY_X); -NODES[7945].Fix(VELOCITY_Y); -NODES[7945].Fix(VELOCITY_Z); -NODES[7946].Fix(VELOCITY_X); -NODES[7946].Fix(VELOCITY_Y); -NODES[7946].Fix(VELOCITY_Z); -NODES[7947].Fix(VELOCITY_X); -NODES[7947].Fix(VELOCITY_Y); -NODES[7947].Fix(VELOCITY_Z); -NODES[7948].Fix(VELOCITY_X); -NODES[7948].Fix(VELOCITY_Y); -NODES[7948].Fix(VELOCITY_Z); -NODES[7949].Fix(VELOCITY_X); -NODES[7949].Fix(VELOCITY_Y); -NODES[7949].Fix(VELOCITY_Z); -NODES[7956].Fix(VELOCITY_X); -NODES[7956].Fix(VELOCITY_Y); -NODES[7956].Fix(VELOCITY_Z); -NODES[7963].Fix(VELOCITY_X); -NODES[7963].Fix(VELOCITY_Y); -NODES[7963].Fix(VELOCITY_Z); -NODES[7964].Fix(VELOCITY_X); -NODES[7964].Fix(VELOCITY_Y); -NODES[7964].Fix(VELOCITY_Z); -NODES[7986].Fix(VELOCITY_X); -NODES[7986].Fix(VELOCITY_Y); -NODES[7986].Fix(VELOCITY_Z); -NODES[7987].Fix(VELOCITY_X); -NODES[7987].Fix(VELOCITY_Y); -NODES[7987].Fix(VELOCITY_Z); -NODES[7988].Fix(VELOCITY_X); -NODES[7988].Fix(VELOCITY_Y); -NODES[7988].Fix(VELOCITY_Z); -NODES[7989].Fix(VELOCITY_X); -NODES[7989].Fix(VELOCITY_Y); -NODES[7989].Fix(VELOCITY_Z); -NODES[7999].Fix(VELOCITY_X); -NODES[7999].Fix(VELOCITY_Y); -NODES[7999].Fix(VELOCITY_Z); -NODES[8003].Fix(VELOCITY_X); -NODES[8003].Fix(VELOCITY_Y); -NODES[8003].Fix(VELOCITY_Z); -NODES[8004].Fix(VELOCITY_X); -NODES[8004].Fix(VELOCITY_Y); -NODES[8004].Fix(VELOCITY_Z); -NODES[8005].Fix(VELOCITY_X); -NODES[8005].Fix(VELOCITY_Y); -NODES[8005].Fix(VELOCITY_Z); -NODES[8008].Fix(VELOCITY_X); -NODES[8008].Fix(VELOCITY_Y); -NODES[8008].Fix(VELOCITY_Z); -NODES[8011].Fix(VELOCITY_X); -NODES[8011].Fix(VELOCITY_Y); -NODES[8011].Fix(VELOCITY_Z); -NODES[8016].Fix(VELOCITY_X); -NODES[8016].Fix(VELOCITY_Y); -NODES[8016].Fix(VELOCITY_Z); -NODES[8025].Fix(VELOCITY_X); -NODES[8025].Fix(VELOCITY_Y); -NODES[8025].Fix(VELOCITY_Z); -NODES[8026].Fix(VELOCITY_X); -NODES[8026].Fix(VELOCITY_Y); -NODES[8026].Fix(VELOCITY_Z); -NODES[8031].Fix(VELOCITY_X); -NODES[8031].Fix(VELOCITY_Y); -NODES[8031].Fix(VELOCITY_Z); -NODES[8037].Fix(VELOCITY_X); -NODES[8037].Fix(VELOCITY_Y); -NODES[8037].Fix(VELOCITY_Z); -NODES[8038].Fix(VELOCITY_X); -NODES[8038].Fix(VELOCITY_Y); -NODES[8038].Fix(VELOCITY_Z); -NODES[8039].Fix(VELOCITY_X); -NODES[8039].Fix(VELOCITY_Y); -NODES[8039].Fix(VELOCITY_Z); -NODES[8040].Fix(VELOCITY_X); -NODES[8040].Fix(VELOCITY_Y); -NODES[8040].Fix(VELOCITY_Z); -NODES[8041].Fix(VELOCITY_X); -NODES[8041].Fix(VELOCITY_Y); -NODES[8041].Fix(VELOCITY_Z); -NODES[8047].Fix(VELOCITY_X); -NODES[8047].Fix(VELOCITY_Y); -NODES[8047].Fix(VELOCITY_Z); -NODES[8059].Fix(VELOCITY_X); -NODES[8059].Fix(VELOCITY_Y); -NODES[8059].Fix(VELOCITY_Z); -NODES[8060].Fix(VELOCITY_X); -NODES[8060].Fix(VELOCITY_Y); -NODES[8060].Fix(VELOCITY_Z); -NODES[8061].Fix(VELOCITY_X); -NODES[8061].Fix(VELOCITY_Y); -NODES[8061].Fix(VELOCITY_Z); -NODES[8077].Fix(VELOCITY_X); -NODES[8077].Fix(VELOCITY_Y); -NODES[8077].Fix(VELOCITY_Z); -NODES[8086].Fix(VELOCITY_X); -NODES[8086].Fix(VELOCITY_Y); -NODES[8086].Fix(VELOCITY_Z); -NODES[8087].Fix(VELOCITY_X); -NODES[8087].Fix(VELOCITY_Y); -NODES[8087].Fix(VELOCITY_Z); -NODES[8088].Fix(VELOCITY_X); -NODES[8088].Fix(VELOCITY_Y); -NODES[8088].Fix(VELOCITY_Z); -NODES[8092].Fix(VELOCITY_X); -NODES[8092].Fix(VELOCITY_Y); -NODES[8092].Fix(VELOCITY_Z); -NODES[8099].Fix(VELOCITY_X); -NODES[8099].Fix(VELOCITY_Y); -NODES[8099].Fix(VELOCITY_Z); -NODES[8100].Fix(VELOCITY_X); -NODES[8100].Fix(VELOCITY_Y); -NODES[8100].Fix(VELOCITY_Z); -NODES[8101].Fix(VELOCITY_X); -NODES[8101].Fix(VELOCITY_Y); -NODES[8101].Fix(VELOCITY_Z); -NODES[8107].Fix(VELOCITY_X); -NODES[8107].Fix(VELOCITY_Y); -NODES[8107].Fix(VELOCITY_Z); -NODES[8108].Fix(VELOCITY_X); -NODES[8108].Fix(VELOCITY_Y); -NODES[8108].Fix(VELOCITY_Z); -NODES[8113].Fix(VELOCITY_X); -NODES[8113].Fix(VELOCITY_Y); -NODES[8113].Fix(VELOCITY_Z); -NODES[8118].Fix(VELOCITY_X); -NODES[8118].Fix(VELOCITY_Y); -NODES[8118].Fix(VELOCITY_Z); -NODES[8119].Fix(VELOCITY_X); -NODES[8119].Fix(VELOCITY_Y); -NODES[8119].Fix(VELOCITY_Z); -NODES[8123].Fix(VELOCITY_X); -NODES[8123].Fix(VELOCITY_Y); -NODES[8123].Fix(VELOCITY_Z); -NODES[8126].Fix(VELOCITY_X); -NODES[8126].Fix(VELOCITY_Y); -NODES[8126].Fix(VELOCITY_Z); -NODES[8127].Fix(VELOCITY_X); -NODES[8127].Fix(VELOCITY_Y); -NODES[8127].Fix(VELOCITY_Z); -NODES[8129].Fix(VELOCITY_X); -NODES[8129].Fix(VELOCITY_Y); -NODES[8129].Fix(VELOCITY_Z); -NODES[8130].Fix(VELOCITY_X); -NODES[8130].Fix(VELOCITY_Y); -NODES[8130].Fix(VELOCITY_Z); -NODES[8131].Fix(VELOCITY_X); -NODES[8131].Fix(VELOCITY_Y); -NODES[8131].Fix(VELOCITY_Z); -NODES[8135].Fix(VELOCITY_X); -NODES[8135].Fix(VELOCITY_Y); -NODES[8135].Fix(VELOCITY_Z); -NODES[8145].Fix(VELOCITY_X); -NODES[8145].Fix(VELOCITY_Y); -NODES[8145].Fix(VELOCITY_Z); -NODES[8146].Fix(VELOCITY_X); -NODES[8146].Fix(VELOCITY_Y); -NODES[8146].Fix(VELOCITY_Z); -NODES[8150].Fix(VELOCITY_X); -NODES[8150].Fix(VELOCITY_Y); -NODES[8150].Fix(VELOCITY_Z); -NODES[8159].Fix(VELOCITY_X); -NODES[8159].Fix(VELOCITY_Y); -NODES[8159].Fix(VELOCITY_Z); -NODES[8167].Fix(VELOCITY_X); -NODES[8167].Fix(VELOCITY_Y); -NODES[8167].Fix(VELOCITY_Z); -NODES[8168].Fix(VELOCITY_X); -NODES[8168].Fix(VELOCITY_Y); -NODES[8168].Fix(VELOCITY_Z); -NODES[8171].Fix(VELOCITY_X); -NODES[8171].Fix(VELOCITY_Y); -NODES[8171].Fix(VELOCITY_Z); -NODES[8172].Fix(VELOCITY_X); -NODES[8172].Fix(VELOCITY_Y); -NODES[8172].Fix(VELOCITY_Z); -NODES[8173].Fix(VELOCITY_X); -NODES[8173].Fix(VELOCITY_Y); -NODES[8173].Fix(VELOCITY_Z); -NODES[8175].Fix(VELOCITY_X); -NODES[8175].Fix(VELOCITY_Y); -NODES[8175].Fix(VELOCITY_Z); -NODES[8177].Fix(VELOCITY_X); -NODES[8177].Fix(VELOCITY_Y); -NODES[8177].Fix(VELOCITY_Z); -NODES[8179].Fix(VELOCITY_X); -NODES[8179].Fix(VELOCITY_Y); -NODES[8179].Fix(VELOCITY_Z); -NODES[8183].Fix(VELOCITY_X); -NODES[8183].Fix(VELOCITY_Y); -NODES[8183].Fix(VELOCITY_Z); -NODES[8186].Fix(VELOCITY_X); -NODES[8186].Fix(VELOCITY_Y); -NODES[8186].Fix(VELOCITY_Z); -NODES[8191].Fix(VELOCITY_X); -NODES[8191].Fix(VELOCITY_Y); -NODES[8191].Fix(VELOCITY_Z); -NODES[8200].Fix(VELOCITY_X); -NODES[8200].Fix(VELOCITY_Y); -NODES[8200].Fix(VELOCITY_Z); -NODES[8214].Fix(VELOCITY_X); -NODES[8214].Fix(VELOCITY_Y); -NODES[8214].Fix(VELOCITY_Z); -NODES[8215].Fix(VELOCITY_X); -NODES[8215].Fix(VELOCITY_Y); -NODES[8215].Fix(VELOCITY_Z); -NODES[8229].Fix(VELOCITY_X); -NODES[8229].Fix(VELOCITY_Y); -NODES[8229].Fix(VELOCITY_Z); -NODES[8234].Fix(VELOCITY_X); -NODES[8234].Fix(VELOCITY_Y); -NODES[8234].Fix(VELOCITY_Z); -NODES[8235].Fix(VELOCITY_X); -NODES[8235].Fix(VELOCITY_Y); -NODES[8235].Fix(VELOCITY_Z); -NODES[8236].Fix(VELOCITY_X); -NODES[8236].Fix(VELOCITY_Y); -NODES[8236].Fix(VELOCITY_Z); -NODES[8237].Fix(VELOCITY_X); -NODES[8237].Fix(VELOCITY_Y); -NODES[8237].Fix(VELOCITY_Z); -NODES[8238].Fix(VELOCITY_X); -NODES[8238].Fix(VELOCITY_Y); -NODES[8238].Fix(VELOCITY_Z); -NODES[8239].Fix(VELOCITY_X); -NODES[8239].Fix(VELOCITY_Y); -NODES[8239].Fix(VELOCITY_Z); -NODES[8240].Fix(VELOCITY_X); -NODES[8240].Fix(VELOCITY_Y); -NODES[8240].Fix(VELOCITY_Z); -NODES[8241].Fix(VELOCITY_X); -NODES[8241].Fix(VELOCITY_Y); -NODES[8241].Fix(VELOCITY_Z); -NODES[8242].Fix(VELOCITY_X); -NODES[8242].Fix(VELOCITY_Y); -NODES[8242].Fix(VELOCITY_Z); -NODES[8248].Fix(VELOCITY_X); -NODES[8248].Fix(VELOCITY_Y); -NODES[8248].Fix(VELOCITY_Z); -NODES[8253].Fix(VELOCITY_X); -NODES[8253].Fix(VELOCITY_Y); -NODES[8253].Fix(VELOCITY_Z); -NODES[8254].Fix(VELOCITY_X); -NODES[8254].Fix(VELOCITY_Y); -NODES[8254].Fix(VELOCITY_Z); -NODES[8255].Fix(VELOCITY_X); -NODES[8255].Fix(VELOCITY_Y); -NODES[8255].Fix(VELOCITY_Z); -NODES[8262].Fix(VELOCITY_X); -NODES[8262].Fix(VELOCITY_Y); -NODES[8262].Fix(VELOCITY_Z); -NODES[8263].Fix(VELOCITY_X); -NODES[8263].Fix(VELOCITY_Y); -NODES[8263].Fix(VELOCITY_Z); -NODES[8264].Fix(VELOCITY_X); -NODES[8264].Fix(VELOCITY_Y); -NODES[8264].Fix(VELOCITY_Z); -NODES[8267].Fix(VELOCITY_X); -NODES[8267].Fix(VELOCITY_Y); -NODES[8267].Fix(VELOCITY_Z); -NODES[8275].Fix(VELOCITY_X); -NODES[8275].Fix(VELOCITY_Y); -NODES[8275].Fix(VELOCITY_Z); -NODES[8277].Fix(VELOCITY_X); -NODES[8277].Fix(VELOCITY_Y); -NODES[8277].Fix(VELOCITY_Z); -NODES[8278].Fix(VELOCITY_X); -NODES[8278].Fix(VELOCITY_Y); -NODES[8278].Fix(VELOCITY_Z); -NODES[8279].Fix(VELOCITY_X); -NODES[8279].Fix(VELOCITY_Y); -NODES[8279].Fix(VELOCITY_Z); -NODES[8280].Fix(VELOCITY_X); -NODES[8280].Fix(VELOCITY_Y); -NODES[8280].Fix(VELOCITY_Z); -NODES[8285].Fix(VELOCITY_X); -NODES[8285].Fix(VELOCITY_Y); -NODES[8285].Fix(VELOCITY_Z); -NODES[8286].Fix(VELOCITY_X); -NODES[8286].Fix(VELOCITY_Y); -NODES[8286].Fix(VELOCITY_Z); -NODES[8287].Fix(VELOCITY_X); -NODES[8287].Fix(VELOCITY_Y); -NODES[8287].Fix(VELOCITY_Z); -NODES[8293].Fix(VELOCITY_X); -NODES[8293].Fix(VELOCITY_Y); -NODES[8293].Fix(VELOCITY_Z); -NODES[8301].Fix(VELOCITY_X); -NODES[8301].Fix(VELOCITY_Y); -NODES[8301].Fix(VELOCITY_Z); -NODES[8313].Fix(VELOCITY_X); -NODES[8313].Fix(VELOCITY_Y); -NODES[8313].Fix(VELOCITY_Z); -NODES[8315].Fix(VELOCITY_X); -NODES[8315].Fix(VELOCITY_Y); -NODES[8315].Fix(VELOCITY_Z); -NODES[8316].Fix(VELOCITY_X); -NODES[8316].Fix(VELOCITY_Y); -NODES[8316].Fix(VELOCITY_Z); -NODES[8317].Fix(VELOCITY_X); -NODES[8317].Fix(VELOCITY_Y); -NODES[8317].Fix(VELOCITY_Z); -NODES[8319].Fix(VELOCITY_X); -NODES[8319].Fix(VELOCITY_Y); -NODES[8319].Fix(VELOCITY_Z); -NODES[8320].Fix(VELOCITY_X); -NODES[8320].Fix(VELOCITY_Y); -NODES[8320].Fix(VELOCITY_Z); -NODES[8328].Fix(VELOCITY_X); -NODES[8328].Fix(VELOCITY_Y); -NODES[8328].Fix(VELOCITY_Z); -NODES[8352].Fix(VELOCITY_X); -NODES[8352].Fix(VELOCITY_Y); -NODES[8352].Fix(VELOCITY_Z); -NODES[8356].Fix(VELOCITY_X); -NODES[8356].Fix(VELOCITY_Y); -NODES[8356].Fix(VELOCITY_Z); -NODES[8357].Fix(VELOCITY_X); -NODES[8357].Fix(VELOCITY_Y); -NODES[8357].Fix(VELOCITY_Z); -NODES[8363].Fix(VELOCITY_X); -NODES[8363].Fix(VELOCITY_Y); -NODES[8363].Fix(VELOCITY_Z); -NODES[8371].Fix(VELOCITY_X); -NODES[8371].Fix(VELOCITY_Y); -NODES[8371].Fix(VELOCITY_Z); -NODES[8377].Fix(VELOCITY_X); -NODES[8377].Fix(VELOCITY_Y); -NODES[8377].Fix(VELOCITY_Z); -NODES[8390].Fix(VELOCITY_X); -NODES[8390].Fix(VELOCITY_Y); -NODES[8390].Fix(VELOCITY_Z); -NODES[8391].Fix(VELOCITY_X); -NODES[8391].Fix(VELOCITY_Y); -NODES[8391].Fix(VELOCITY_Z); -NODES[8392].Fix(VELOCITY_X); -NODES[8392].Fix(VELOCITY_Y); -NODES[8392].Fix(VELOCITY_Z); -NODES[8393].Fix(VELOCITY_X); -NODES[8393].Fix(VELOCITY_Y); -NODES[8393].Fix(VELOCITY_Z); -NODES[8394].Fix(VELOCITY_X); -NODES[8394].Fix(VELOCITY_Y); -NODES[8394].Fix(VELOCITY_Z); -NODES[8400].Fix(VELOCITY_X); -NODES[8400].Fix(VELOCITY_Y); -NODES[8400].Fix(VELOCITY_Z); -NODES[8401].Fix(VELOCITY_X); -NODES[8401].Fix(VELOCITY_Y); -NODES[8401].Fix(VELOCITY_Z); -NODES[8403].Fix(VELOCITY_X); -NODES[8403].Fix(VELOCITY_Y); -NODES[8403].Fix(VELOCITY_Z); -NODES[8407].Fix(VELOCITY_X); -NODES[8407].Fix(VELOCITY_Y); -NODES[8407].Fix(VELOCITY_Z); -NODES[8408].Fix(VELOCITY_X); -NODES[8408].Fix(VELOCITY_Y); -NODES[8408].Fix(VELOCITY_Z); -NODES[8419].Fix(VELOCITY_X); -NODES[8419].Fix(VELOCITY_Y); -NODES[8419].Fix(VELOCITY_Z); -NODES[8420].Fix(VELOCITY_X); -NODES[8420].Fix(VELOCITY_Y); -NODES[8420].Fix(VELOCITY_Z); -NODES[8421].Fix(VELOCITY_X); -NODES[8421].Fix(VELOCITY_Y); -NODES[8421].Fix(VELOCITY_Z); -NODES[8422].Fix(VELOCITY_X); -NODES[8422].Fix(VELOCITY_Y); -NODES[8422].Fix(VELOCITY_Z); -NODES[8434].Fix(VELOCITY_X); -NODES[8434].Fix(VELOCITY_Y); -NODES[8434].Fix(VELOCITY_Z); -NODES[8435].Fix(VELOCITY_X); -NODES[8435].Fix(VELOCITY_Y); -NODES[8435].Fix(VELOCITY_Z); -NODES[8436].Fix(VELOCITY_X); -NODES[8436].Fix(VELOCITY_Y); -NODES[8436].Fix(VELOCITY_Z); -NODES[8443].Fix(VELOCITY_X); -NODES[8443].Fix(VELOCITY_Y); -NODES[8443].Fix(VELOCITY_Z); -NODES[8445].Fix(VELOCITY_X); -NODES[8445].Fix(VELOCITY_Y); -NODES[8445].Fix(VELOCITY_Z); -NODES[8454].Fix(VELOCITY_X); -NODES[8454].Fix(VELOCITY_Y); -NODES[8454].Fix(VELOCITY_Z); -NODES[8456].Fix(VELOCITY_X); -NODES[8456].Fix(VELOCITY_Y); -NODES[8456].Fix(VELOCITY_Z); -NODES[8472].Fix(VELOCITY_X); -NODES[8472].Fix(VELOCITY_Y); -NODES[8472].Fix(VELOCITY_Z); -NODES[8476].Fix(VELOCITY_X); -NODES[8476].Fix(VELOCITY_Y); -NODES[8476].Fix(VELOCITY_Z); -NODES[8480].Fix(VELOCITY_X); -NODES[8480].Fix(VELOCITY_Y); -NODES[8480].Fix(VELOCITY_Z); -NODES[8481].Fix(VELOCITY_X); -NODES[8481].Fix(VELOCITY_Y); -NODES[8481].Fix(VELOCITY_Z); -NODES[8482].Fix(VELOCITY_X); -NODES[8482].Fix(VELOCITY_Y); -NODES[8482].Fix(VELOCITY_Z); -NODES[8490].Fix(VELOCITY_X); -NODES[8490].Fix(VELOCITY_Y); -NODES[8490].Fix(VELOCITY_Z); -NODES[8504].Fix(VELOCITY_X); -NODES[8504].Fix(VELOCITY_Y); -NODES[8504].Fix(VELOCITY_Z); -NODES[8508].Fix(VELOCITY_X); -NODES[8508].Fix(VELOCITY_Y); -NODES[8508].Fix(VELOCITY_Z); -NODES[8513].Fix(VELOCITY_X); -NODES[8513].Fix(VELOCITY_Y); -NODES[8513].Fix(VELOCITY_Z); -NODES[8516].Fix(VELOCITY_X); -NODES[8516].Fix(VELOCITY_Y); -NODES[8516].Fix(VELOCITY_Z); -NODES[8521].Fix(VELOCITY_X); -NODES[8521].Fix(VELOCITY_Y); -NODES[8521].Fix(VELOCITY_Z); -NODES[8526].Fix(VELOCITY_X); -NODES[8526].Fix(VELOCITY_Y); -NODES[8526].Fix(VELOCITY_Z); -NODES[8527].Fix(VELOCITY_X); -NODES[8527].Fix(VELOCITY_Y); -NODES[8527].Fix(VELOCITY_Z); -NODES[8528].Fix(VELOCITY_X); -NODES[8528].Fix(VELOCITY_Y); -NODES[8528].Fix(VELOCITY_Z); -NODES[8539].Fix(VELOCITY_X); -NODES[8539].Fix(VELOCITY_Y); -NODES[8539].Fix(VELOCITY_Z); -NODES[8544].Fix(VELOCITY_X); -NODES[8544].Fix(VELOCITY_Y); -NODES[8544].Fix(VELOCITY_Z); -NODES[8553].Fix(VELOCITY_X); -NODES[8553].Fix(VELOCITY_Y); -NODES[8553].Fix(VELOCITY_Z); -NODES[8554].Fix(VELOCITY_X); -NODES[8554].Fix(VELOCITY_Y); -NODES[8554].Fix(VELOCITY_Z); -NODES[8555].Fix(VELOCITY_X); -NODES[8555].Fix(VELOCITY_Y); -NODES[8555].Fix(VELOCITY_Z); -NODES[8557].Fix(VELOCITY_X); -NODES[8557].Fix(VELOCITY_Y); -NODES[8557].Fix(VELOCITY_Z); -NODES[8558].Fix(VELOCITY_X); -NODES[8558].Fix(VELOCITY_Y); -NODES[8558].Fix(VELOCITY_Z); -NODES[8559].Fix(VELOCITY_X); -NODES[8559].Fix(VELOCITY_Y); -NODES[8559].Fix(VELOCITY_Z); -NODES[8560].Fix(VELOCITY_X); -NODES[8560].Fix(VELOCITY_Y); -NODES[8560].Fix(VELOCITY_Z); -NODES[8561].Fix(VELOCITY_X); -NODES[8561].Fix(VELOCITY_Y); -NODES[8561].Fix(VELOCITY_Z); -NODES[8562].Fix(VELOCITY_X); -NODES[8562].Fix(VELOCITY_Y); -NODES[8562].Fix(VELOCITY_Z); -NODES[8563].Fix(VELOCITY_X); -NODES[8563].Fix(VELOCITY_Y); -NODES[8563].Fix(VELOCITY_Z); -NODES[8564].Fix(VELOCITY_X); -NODES[8564].Fix(VELOCITY_Y); -NODES[8564].Fix(VELOCITY_Z); -NODES[8565].Fix(VELOCITY_X); -NODES[8565].Fix(VELOCITY_Y); -NODES[8565].Fix(VELOCITY_Z); -NODES[8571].Fix(VELOCITY_X); -NODES[8571].Fix(VELOCITY_Y); -NODES[8571].Fix(VELOCITY_Z); -NODES[8572].Fix(VELOCITY_X); -NODES[8572].Fix(VELOCITY_Y); -NODES[8572].Fix(VELOCITY_Z); -NODES[8577].Fix(VELOCITY_X); -NODES[8577].Fix(VELOCITY_Y); -NODES[8577].Fix(VELOCITY_Z); -NODES[8579].Fix(VELOCITY_X); -NODES[8579].Fix(VELOCITY_Y); -NODES[8579].Fix(VELOCITY_Z); -NODES[8583].Fix(VELOCITY_X); -NODES[8583].Fix(VELOCITY_Y); -NODES[8583].Fix(VELOCITY_Z); -NODES[8600].Fix(VELOCITY_X); -NODES[8600].Fix(VELOCITY_Y); -NODES[8600].Fix(VELOCITY_Z); -NODES[8601].Fix(VELOCITY_X); -NODES[8601].Fix(VELOCITY_Y); -NODES[8601].Fix(VELOCITY_Z); -NODES[8602].Fix(VELOCITY_X); -NODES[8602].Fix(VELOCITY_Y); -NODES[8602].Fix(VELOCITY_Z); -NODES[8609].Fix(VELOCITY_X); -NODES[8609].Fix(VELOCITY_Y); -NODES[8609].Fix(VELOCITY_Z); -NODES[8611].Fix(VELOCITY_X); -NODES[8611].Fix(VELOCITY_Y); -NODES[8611].Fix(VELOCITY_Z); -NODES[8617].Fix(VELOCITY_X); -NODES[8617].Fix(VELOCITY_Y); -NODES[8617].Fix(VELOCITY_Z); -NODES[8624].Fix(VELOCITY_X); -NODES[8624].Fix(VELOCITY_Y); -NODES[8624].Fix(VELOCITY_Z); -NODES[8625].Fix(VELOCITY_X); -NODES[8625].Fix(VELOCITY_Y); -NODES[8625].Fix(VELOCITY_Z); -NODES[8626].Fix(VELOCITY_X); -NODES[8626].Fix(VELOCITY_Y); -NODES[8626].Fix(VELOCITY_Z); -NODES[8630].Fix(VELOCITY_X); -NODES[8630].Fix(VELOCITY_Y); -NODES[8630].Fix(VELOCITY_Z); -NODES[8632].Fix(VELOCITY_X); -NODES[8632].Fix(VELOCITY_Y); -NODES[8632].Fix(VELOCITY_Z); -NODES[8637].Fix(VELOCITY_X); -NODES[8637].Fix(VELOCITY_Y); -NODES[8637].Fix(VELOCITY_Z); -NODES[8652].Fix(VELOCITY_X); -NODES[8652].Fix(VELOCITY_Y); -NODES[8652].Fix(VELOCITY_Z); -NODES[8662].Fix(VELOCITY_X); -NODES[8662].Fix(VELOCITY_Y); -NODES[8662].Fix(VELOCITY_Z); -NODES[8679].Fix(VELOCITY_X); -NODES[8679].Fix(VELOCITY_Y); -NODES[8679].Fix(VELOCITY_Z); -NODES[8681].Fix(VELOCITY_X); -NODES[8681].Fix(VELOCITY_Y); -NODES[8681].Fix(VELOCITY_Z); -NODES[8690].Fix(VELOCITY_X); -NODES[8690].Fix(VELOCITY_Y); -NODES[8690].Fix(VELOCITY_Z); -NODES[8697].Fix(VELOCITY_X); -NODES[8697].Fix(VELOCITY_Y); -NODES[8697].Fix(VELOCITY_Z); -NODES[8700].Fix(VELOCITY_X); -NODES[8700].Fix(VELOCITY_Y); -NODES[8700].Fix(VELOCITY_Z); -NODES[8701].Fix(VELOCITY_X); -NODES[8701].Fix(VELOCITY_Y); -NODES[8701].Fix(VELOCITY_Z); -NODES[8703].Fix(VELOCITY_X); -NODES[8703].Fix(VELOCITY_Y); -NODES[8703].Fix(VELOCITY_Z); -NODES[8705].Fix(VELOCITY_X); -NODES[8705].Fix(VELOCITY_Y); -NODES[8705].Fix(VELOCITY_Z); -NODES[8713].Fix(VELOCITY_X); -NODES[8713].Fix(VELOCITY_Y); -NODES[8713].Fix(VELOCITY_Z); -NODES[8715].Fix(VELOCITY_X); -NODES[8715].Fix(VELOCITY_Y); -NODES[8715].Fix(VELOCITY_Z); -NODES[8716].Fix(VELOCITY_X); -NODES[8716].Fix(VELOCITY_Y); -NODES[8716].Fix(VELOCITY_Z); -NODES[8717].Fix(VELOCITY_X); -NODES[8717].Fix(VELOCITY_Y); -NODES[8717].Fix(VELOCITY_Z); -NODES[8719].Fix(VELOCITY_X); -NODES[8719].Fix(VELOCITY_Y); -NODES[8719].Fix(VELOCITY_Z); -NODES[8724].Fix(VELOCITY_X); -NODES[8724].Fix(VELOCITY_Y); -NODES[8724].Fix(VELOCITY_Z); -NODES[8725].Fix(VELOCITY_X); -NODES[8725].Fix(VELOCITY_Y); -NODES[8725].Fix(VELOCITY_Z); -NODES[8730].Fix(VELOCITY_X); -NODES[8730].Fix(VELOCITY_Y); -NODES[8730].Fix(VELOCITY_Z); -NODES[8732].Fix(VELOCITY_X); -NODES[8732].Fix(VELOCITY_Y); -NODES[8732].Fix(VELOCITY_Z); -NODES[8733].Fix(VELOCITY_X); -NODES[8733].Fix(VELOCITY_Y); -NODES[8733].Fix(VELOCITY_Z); -NODES[8738].Fix(VELOCITY_X); -NODES[8738].Fix(VELOCITY_Y); -NODES[8738].Fix(VELOCITY_Z); -NODES[8744].Fix(VELOCITY_X); -NODES[8744].Fix(VELOCITY_Y); -NODES[8744].Fix(VELOCITY_Z); -NODES[8760].Fix(VELOCITY_X); -NODES[8760].Fix(VELOCITY_Y); -NODES[8760].Fix(VELOCITY_Z); -NODES[8761].Fix(VELOCITY_X); -NODES[8761].Fix(VELOCITY_Y); -NODES[8761].Fix(VELOCITY_Z); -NODES[8762].Fix(VELOCITY_X); -NODES[8762].Fix(VELOCITY_Y); -NODES[8762].Fix(VELOCITY_Z); -NODES[8780].Fix(VELOCITY_X); -NODES[8780].Fix(VELOCITY_Y); -NODES[8780].Fix(VELOCITY_Z); -NODES[8782].Fix(VELOCITY_X); -NODES[8782].Fix(VELOCITY_Y); -NODES[8782].Fix(VELOCITY_Z); -NODES[8787].Fix(VELOCITY_X); -NODES[8787].Fix(VELOCITY_Y); -NODES[8787].Fix(VELOCITY_Z); -NODES[8802].Fix(VELOCITY_X); -NODES[8802].Fix(VELOCITY_Y); -NODES[8802].Fix(VELOCITY_Z); -NODES[8812].Fix(VELOCITY_X); -NODES[8812].Fix(VELOCITY_Y); -NODES[8812].Fix(VELOCITY_Z); -NODES[8824].Fix(VELOCITY_X); -NODES[8824].Fix(VELOCITY_Y); -NODES[8824].Fix(VELOCITY_Z); -NODES[8825].Fix(VELOCITY_X); -NODES[8825].Fix(VELOCITY_Y); -NODES[8825].Fix(VELOCITY_Z); -NODES[8826].Fix(VELOCITY_X); -NODES[8826].Fix(VELOCITY_Y); -NODES[8826].Fix(VELOCITY_Z); -NODES[8827].Fix(VELOCITY_X); -NODES[8827].Fix(VELOCITY_Y); -NODES[8827].Fix(VELOCITY_Z); -NODES[8828].Fix(VELOCITY_X); -NODES[8828].Fix(VELOCITY_Y); -NODES[8828].Fix(VELOCITY_Z); -NODES[8836].Fix(VELOCITY_X); -NODES[8836].Fix(VELOCITY_Y); -NODES[8836].Fix(VELOCITY_Z); -NODES[8853].Fix(VELOCITY_X); -NODES[8853].Fix(VELOCITY_Y); -NODES[8853].Fix(VELOCITY_Z); -NODES[8856].Fix(VELOCITY_X); -NODES[8856].Fix(VELOCITY_Y); -NODES[8856].Fix(VELOCITY_Z); -NODES[8857].Fix(VELOCITY_X); -NODES[8857].Fix(VELOCITY_Y); -NODES[8857].Fix(VELOCITY_Z); -NODES[8862].Fix(VELOCITY_X); -NODES[8862].Fix(VELOCITY_Y); -NODES[8862].Fix(VELOCITY_Z); -NODES[8868].Fix(VELOCITY_X); -NODES[8868].Fix(VELOCITY_Y); -NODES[8868].Fix(VELOCITY_Z); -NODES[8870].Fix(VELOCITY_X); -NODES[8870].Fix(VELOCITY_Y); -NODES[8870].Fix(VELOCITY_Z); -NODES[8872].Fix(VELOCITY_X); -NODES[8872].Fix(VELOCITY_Y); -NODES[8872].Fix(VELOCITY_Z); -NODES[8873].Fix(VELOCITY_X); -NODES[8873].Fix(VELOCITY_Y); -NODES[8873].Fix(VELOCITY_Z); -NODES[8879].Fix(VELOCITY_X); -NODES[8879].Fix(VELOCITY_Y); -NODES[8879].Fix(VELOCITY_Z); -NODES[8887].Fix(VELOCITY_X); -NODES[8887].Fix(VELOCITY_Y); -NODES[8887].Fix(VELOCITY_Z); -NODES[8888].Fix(VELOCITY_X); -NODES[8888].Fix(VELOCITY_Y); -NODES[8888].Fix(VELOCITY_Z); -NODES[8892].Fix(VELOCITY_X); -NODES[8892].Fix(VELOCITY_Y); -NODES[8892].Fix(VELOCITY_Z); -NODES[8893].Fix(VELOCITY_X); -NODES[8893].Fix(VELOCITY_Y); -NODES[8893].Fix(VELOCITY_Z); -NODES[8894].Fix(VELOCITY_X); -NODES[8894].Fix(VELOCITY_Y); -NODES[8894].Fix(VELOCITY_Z); -NODES[8896].Fix(VELOCITY_X); -NODES[8896].Fix(VELOCITY_Y); -NODES[8896].Fix(VELOCITY_Z); -NODES[8899].Fix(VELOCITY_X); -NODES[8899].Fix(VELOCITY_Y); -NODES[8899].Fix(VELOCITY_Z); -NODES[8900].Fix(VELOCITY_X); -NODES[8900].Fix(VELOCITY_Y); -NODES[8900].Fix(VELOCITY_Z); -NODES[8901].Fix(VELOCITY_X); -NODES[8901].Fix(VELOCITY_Y); -NODES[8901].Fix(VELOCITY_Z); -NODES[8904].Fix(VELOCITY_X); -NODES[8904].Fix(VELOCITY_Y); -NODES[8904].Fix(VELOCITY_Z); -NODES[8921].Fix(VELOCITY_X); -NODES[8921].Fix(VELOCITY_Y); -NODES[8921].Fix(VELOCITY_Z); -NODES[8922].Fix(VELOCITY_X); -NODES[8922].Fix(VELOCITY_Y); -NODES[8922].Fix(VELOCITY_Z); -NODES[8924].Fix(VELOCITY_X); -NODES[8924].Fix(VELOCITY_Y); -NODES[8924].Fix(VELOCITY_Z); -NODES[8930].Fix(VELOCITY_X); -NODES[8930].Fix(VELOCITY_Y); -NODES[8930].Fix(VELOCITY_Z); -NODES[8931].Fix(VELOCITY_X); -NODES[8931].Fix(VELOCITY_Y); -NODES[8931].Fix(VELOCITY_Z); -NODES[8932].Fix(VELOCITY_X); -NODES[8932].Fix(VELOCITY_Y); -NODES[8932].Fix(VELOCITY_Z); -NODES[8937].Fix(VELOCITY_X); -NODES[8937].Fix(VELOCITY_Y); -NODES[8937].Fix(VELOCITY_Z); -NODES[8938].Fix(VELOCITY_X); -NODES[8938].Fix(VELOCITY_Y); -NODES[8938].Fix(VELOCITY_Z); -NODES[8939].Fix(VELOCITY_X); -NODES[8939].Fix(VELOCITY_Y); -NODES[8939].Fix(VELOCITY_Z); -NODES[8940].Fix(VELOCITY_X); -NODES[8940].Fix(VELOCITY_Y); -NODES[8940].Fix(VELOCITY_Z); -NODES[8941].Fix(VELOCITY_X); -NODES[8941].Fix(VELOCITY_Y); -NODES[8941].Fix(VELOCITY_Z); -NODES[8942].Fix(VELOCITY_X); -NODES[8942].Fix(VELOCITY_Y); -NODES[8942].Fix(VELOCITY_Z); -NODES[8943].Fix(VELOCITY_X); -NODES[8943].Fix(VELOCITY_Y); -NODES[8943].Fix(VELOCITY_Z); -NODES[8944].Fix(VELOCITY_X); -NODES[8944].Fix(VELOCITY_Y); -NODES[8944].Fix(VELOCITY_Z); -NODES[8953].Fix(VELOCITY_X); -NODES[8953].Fix(VELOCITY_Y); -NODES[8953].Fix(VELOCITY_Z); -NODES[8967].Fix(VELOCITY_X); -NODES[8967].Fix(VELOCITY_Y); -NODES[8967].Fix(VELOCITY_Z); -NODES[8972].Fix(VELOCITY_X); -NODES[8972].Fix(VELOCITY_Y); -NODES[8972].Fix(VELOCITY_Z); -NODES[8973].Fix(VELOCITY_X); -NODES[8973].Fix(VELOCITY_Y); -NODES[8973].Fix(VELOCITY_Z); -NODES[8974].Fix(VELOCITY_X); -NODES[8974].Fix(VELOCITY_Y); -NODES[8974].Fix(VELOCITY_Z); -NODES[8975].Fix(VELOCITY_X); -NODES[8975].Fix(VELOCITY_Y); -NODES[8975].Fix(VELOCITY_Z); -NODES[8980].Fix(VELOCITY_X); -NODES[8980].Fix(VELOCITY_Y); -NODES[8980].Fix(VELOCITY_Z); -NODES[8983].Fix(VELOCITY_X); -NODES[8983].Fix(VELOCITY_Y); -NODES[8983].Fix(VELOCITY_Z); -NODES[8984].Fix(VELOCITY_X); -NODES[8984].Fix(VELOCITY_Y); -NODES[8984].Fix(VELOCITY_Z); -NODES[8985].Fix(VELOCITY_X); -NODES[8985].Fix(VELOCITY_Y); -NODES[8985].Fix(VELOCITY_Z); -NODES[8986].Fix(VELOCITY_X); -NODES[8986].Fix(VELOCITY_Y); -NODES[8986].Fix(VELOCITY_Z); -NODES[8992].Fix(VELOCITY_X); -NODES[8992].Fix(VELOCITY_Y); -NODES[8992].Fix(VELOCITY_Z); -NODES[8993].Fix(VELOCITY_X); -NODES[8993].Fix(VELOCITY_Y); -NODES[8993].Fix(VELOCITY_Z); -NODES[9006].Fix(VELOCITY_X); -NODES[9006].Fix(VELOCITY_Y); -NODES[9006].Fix(VELOCITY_Z); -NODES[9007].Fix(VELOCITY_X); -NODES[9007].Fix(VELOCITY_Y); -NODES[9007].Fix(VELOCITY_Z); -NODES[9010].Fix(VELOCITY_X); -NODES[9010].Fix(VELOCITY_Y); -NODES[9010].Fix(VELOCITY_Z); -NODES[9018].Fix(VELOCITY_X); -NODES[9018].Fix(VELOCITY_Y); -NODES[9018].Fix(VELOCITY_Z); -NODES[9023].Fix(VELOCITY_X); -NODES[9023].Fix(VELOCITY_Y); -NODES[9023].Fix(VELOCITY_Z); -NODES[9025].Fix(VELOCITY_X); -NODES[9025].Fix(VELOCITY_Y); -NODES[9025].Fix(VELOCITY_Z); -NODES[9026].Fix(VELOCITY_X); -NODES[9026].Fix(VELOCITY_Y); -NODES[9026].Fix(VELOCITY_Z); -NODES[9031].Fix(VELOCITY_X); -NODES[9031].Fix(VELOCITY_Y); -NODES[9031].Fix(VELOCITY_Z); -NODES[9048].Fix(VELOCITY_X); -NODES[9048].Fix(VELOCITY_Y); -NODES[9048].Fix(VELOCITY_Z); -NODES[9049].Fix(VELOCITY_X); -NODES[9049].Fix(VELOCITY_Y); -NODES[9049].Fix(VELOCITY_Z); -NODES[9056].Fix(VELOCITY_X); -NODES[9056].Fix(VELOCITY_Y); -NODES[9056].Fix(VELOCITY_Z); -NODES[9059].Fix(VELOCITY_X); -NODES[9059].Fix(VELOCITY_Y); -NODES[9059].Fix(VELOCITY_Z); -NODES[9060].Fix(VELOCITY_X); -NODES[9060].Fix(VELOCITY_Y); -NODES[9060].Fix(VELOCITY_Z); -NODES[9066].Fix(VELOCITY_X); -NODES[9066].Fix(VELOCITY_Y); -NODES[9066].Fix(VELOCITY_Z); -NODES[9071].Fix(VELOCITY_X); -NODES[9071].Fix(VELOCITY_Y); -NODES[9071].Fix(VELOCITY_Z); -NODES[9076].Fix(VELOCITY_X); -NODES[9076].Fix(VELOCITY_Y); -NODES[9076].Fix(VELOCITY_Z); -NODES[9077].Fix(VELOCITY_X); -NODES[9077].Fix(VELOCITY_Y); -NODES[9077].Fix(VELOCITY_Z); -NODES[9078].Fix(VELOCITY_X); -NODES[9078].Fix(VELOCITY_Y); -NODES[9078].Fix(VELOCITY_Z); -NODES[9092].Fix(VELOCITY_X); -NODES[9092].Fix(VELOCITY_Y); -NODES[9092].Fix(VELOCITY_Z); -NODES[9100].Fix(VELOCITY_X); -NODES[9100].Fix(VELOCITY_Y); -NODES[9100].Fix(VELOCITY_Z); -NODES[9101].Fix(VELOCITY_X); -NODES[9101].Fix(VELOCITY_Y); -NODES[9101].Fix(VELOCITY_Z); -NODES[9122].Fix(VELOCITY_X); -NODES[9122].Fix(VELOCITY_Y); -NODES[9122].Fix(VELOCITY_Z); -NODES[9123].Fix(VELOCITY_X); -NODES[9123].Fix(VELOCITY_Y); -NODES[9123].Fix(VELOCITY_Z); -NODES[9124].Fix(VELOCITY_X); -NODES[9124].Fix(VELOCITY_Y); -NODES[9124].Fix(VELOCITY_Z); -NODES[9125].Fix(VELOCITY_X); -NODES[9125].Fix(VELOCITY_Y); -NODES[9125].Fix(VELOCITY_Z); -NODES[9134].Fix(VELOCITY_X); -NODES[9134].Fix(VELOCITY_Y); -NODES[9134].Fix(VELOCITY_Z); -NODES[9136].Fix(VELOCITY_X); -NODES[9136].Fix(VELOCITY_Y); -NODES[9136].Fix(VELOCITY_Z); -NODES[9137].Fix(VELOCITY_X); -NODES[9137].Fix(VELOCITY_Y); -NODES[9137].Fix(VELOCITY_Z); -NODES[9147].Fix(VELOCITY_X); -NODES[9147].Fix(VELOCITY_Y); -NODES[9147].Fix(VELOCITY_Z); -NODES[9154].Fix(VELOCITY_X); -NODES[9154].Fix(VELOCITY_Y); -NODES[9154].Fix(VELOCITY_Z); -NODES[9155].Fix(VELOCITY_X); -NODES[9155].Fix(VELOCITY_Y); -NODES[9155].Fix(VELOCITY_Z); -NODES[9158].Fix(VELOCITY_X); -NODES[9158].Fix(VELOCITY_Y); -NODES[9158].Fix(VELOCITY_Z); -NODES[9159].Fix(VELOCITY_X); -NODES[9159].Fix(VELOCITY_Y); -NODES[9159].Fix(VELOCITY_Z); -NODES[9162].Fix(VELOCITY_X); -NODES[9162].Fix(VELOCITY_Y); -NODES[9162].Fix(VELOCITY_Z); -NODES[9163].Fix(VELOCITY_X); -NODES[9163].Fix(VELOCITY_Y); -NODES[9163].Fix(VELOCITY_Z); -NODES[9166].Fix(VELOCITY_X); -NODES[9166].Fix(VELOCITY_Y); -NODES[9166].Fix(VELOCITY_Z); -NODES[9167].Fix(VELOCITY_X); -NODES[9167].Fix(VELOCITY_Y); -NODES[9167].Fix(VELOCITY_Z); -NODES[9168].Fix(VELOCITY_X); -NODES[9168].Fix(VELOCITY_Y); -NODES[9168].Fix(VELOCITY_Z); -NODES[9172].Fix(VELOCITY_X); -NODES[9172].Fix(VELOCITY_Y); -NODES[9172].Fix(VELOCITY_Z); -NODES[9188].Fix(VELOCITY_X); -NODES[9188].Fix(VELOCITY_Y); -NODES[9188].Fix(VELOCITY_Z); -NODES[9193].Fix(VELOCITY_X); -NODES[9193].Fix(VELOCITY_Y); -NODES[9193].Fix(VELOCITY_Z); -NODES[9194].Fix(VELOCITY_X); -NODES[9194].Fix(VELOCITY_Y); -NODES[9194].Fix(VELOCITY_Z); -NODES[9195].Fix(VELOCITY_X); -NODES[9195].Fix(VELOCITY_Y); -NODES[9195].Fix(VELOCITY_Z); -NODES[9196].Fix(VELOCITY_X); -NODES[9196].Fix(VELOCITY_Y); -NODES[9196].Fix(VELOCITY_Z); -NODES[9197].Fix(VELOCITY_X); -NODES[9197].Fix(VELOCITY_Y); -NODES[9197].Fix(VELOCITY_Z); -NODES[9198].Fix(VELOCITY_X); -NODES[9198].Fix(VELOCITY_Y); -NODES[9198].Fix(VELOCITY_Z); -NODES[9199].Fix(VELOCITY_X); -NODES[9199].Fix(VELOCITY_Y); -NODES[9199].Fix(VELOCITY_Z); -NODES[9218].Fix(VELOCITY_X); -NODES[9218].Fix(VELOCITY_Y); -NODES[9218].Fix(VELOCITY_Z); -NODES[9222].Fix(VELOCITY_X); -NODES[9222].Fix(VELOCITY_Y); -NODES[9222].Fix(VELOCITY_Z); -NODES[9232].Fix(VELOCITY_X); -NODES[9232].Fix(VELOCITY_Y); -NODES[9232].Fix(VELOCITY_Z); -NODES[9233].Fix(VELOCITY_X); -NODES[9233].Fix(VELOCITY_Y); -NODES[9233].Fix(VELOCITY_Z); -NODES[9245].Fix(VELOCITY_X); -NODES[9245].Fix(VELOCITY_Y); -NODES[9245].Fix(VELOCITY_Z); -NODES[9248].Fix(VELOCITY_X); -NODES[9248].Fix(VELOCITY_Y); -NODES[9248].Fix(VELOCITY_Z); -NODES[9249].Fix(VELOCITY_X); -NODES[9249].Fix(VELOCITY_Y); -NODES[9249].Fix(VELOCITY_Z); -NODES[9250].Fix(VELOCITY_X); -NODES[9250].Fix(VELOCITY_Y); -NODES[9250].Fix(VELOCITY_Z); -NODES[9251].Fix(VELOCITY_X); -NODES[9251].Fix(VELOCITY_Y); -NODES[9251].Fix(VELOCITY_Z); -NODES[9254].Fix(VELOCITY_X); -NODES[9254].Fix(VELOCITY_Y); -NODES[9254].Fix(VELOCITY_Z); -NODES[9256].Fix(VELOCITY_X); -NODES[9256].Fix(VELOCITY_Y); -NODES[9256].Fix(VELOCITY_Z); -NODES[9272].Fix(VELOCITY_X); -NODES[9272].Fix(VELOCITY_Y); -NODES[9272].Fix(VELOCITY_Z); -NODES[9273].Fix(VELOCITY_X); -NODES[9273].Fix(VELOCITY_Y); -NODES[9273].Fix(VELOCITY_Z); -NODES[9275].Fix(VELOCITY_X); -NODES[9275].Fix(VELOCITY_Y); -NODES[9275].Fix(VELOCITY_Z); -NODES[9277].Fix(VELOCITY_X); -NODES[9277].Fix(VELOCITY_Y); -NODES[9277].Fix(VELOCITY_Z); -NODES[9278].Fix(VELOCITY_X); -NODES[9278].Fix(VELOCITY_Y); -NODES[9278].Fix(VELOCITY_Z); -NODES[9282].Fix(VELOCITY_X); -NODES[9282].Fix(VELOCITY_Y); -NODES[9282].Fix(VELOCITY_Z); -NODES[9283].Fix(VELOCITY_X); -NODES[9283].Fix(VELOCITY_Y); -NODES[9283].Fix(VELOCITY_Z); -NODES[9291].Fix(VELOCITY_X); -NODES[9291].Fix(VELOCITY_Y); -NODES[9291].Fix(VELOCITY_Z); -NODES[9292].Fix(VELOCITY_X); -NODES[9292].Fix(VELOCITY_Y); -NODES[9292].Fix(VELOCITY_Z); -NODES[9300].Fix(VELOCITY_X); -NODES[9300].Fix(VELOCITY_Y); -NODES[9300].Fix(VELOCITY_Z); -NODES[9301].Fix(VELOCITY_X); -NODES[9301].Fix(VELOCITY_Y); -NODES[9301].Fix(VELOCITY_Z); -NODES[9302].Fix(VELOCITY_X); -NODES[9302].Fix(VELOCITY_Y); -NODES[9302].Fix(VELOCITY_Z); -NODES[9303].Fix(VELOCITY_X); -NODES[9303].Fix(VELOCITY_Y); -NODES[9303].Fix(VELOCITY_Z); -NODES[9304].Fix(VELOCITY_X); -NODES[9304].Fix(VELOCITY_Y); -NODES[9304].Fix(VELOCITY_Z); -NODES[9305].Fix(VELOCITY_X); -NODES[9305].Fix(VELOCITY_Y); -NODES[9305].Fix(VELOCITY_Z); -NODES[9315].Fix(VELOCITY_X); -NODES[9315].Fix(VELOCITY_Y); -NODES[9315].Fix(VELOCITY_Z); -NODES[9318].Fix(VELOCITY_X); -NODES[9318].Fix(VELOCITY_Y); -NODES[9318].Fix(VELOCITY_Z); -NODES[9324].Fix(VELOCITY_X); -NODES[9324].Fix(VELOCITY_Y); -NODES[9324].Fix(VELOCITY_Z); -NODES[9326].Fix(VELOCITY_X); -NODES[9326].Fix(VELOCITY_Y); -NODES[9326].Fix(VELOCITY_Z); -NODES[9332].Fix(VELOCITY_X); -NODES[9332].Fix(VELOCITY_Y); -NODES[9332].Fix(VELOCITY_Z); -NODES[9339].Fix(VELOCITY_X); -NODES[9339].Fix(VELOCITY_Y); -NODES[9339].Fix(VELOCITY_Z); -NODES[9342].Fix(VELOCITY_X); -NODES[9342].Fix(VELOCITY_Y); -NODES[9342].Fix(VELOCITY_Z); -NODES[9343].Fix(VELOCITY_X); -NODES[9343].Fix(VELOCITY_Y); -NODES[9343].Fix(VELOCITY_Z); -NODES[9344].Fix(VELOCITY_X); -NODES[9344].Fix(VELOCITY_Y); -NODES[9344].Fix(VELOCITY_Z); -NODES[9345].Fix(VELOCITY_X); -NODES[9345].Fix(VELOCITY_Y); -NODES[9345].Fix(VELOCITY_Z); -NODES[9346].Fix(VELOCITY_X); -NODES[9346].Fix(VELOCITY_Y); -NODES[9346].Fix(VELOCITY_Z); -NODES[9347].Fix(VELOCITY_X); -NODES[9347].Fix(VELOCITY_Y); -NODES[9347].Fix(VELOCITY_Z); -NODES[9349].Fix(VELOCITY_X); -NODES[9349].Fix(VELOCITY_Y); -NODES[9349].Fix(VELOCITY_Z); -NODES[9369].Fix(VELOCITY_X); -NODES[9369].Fix(VELOCITY_Y); -NODES[9369].Fix(VELOCITY_Z); -NODES[9370].Fix(VELOCITY_X); -NODES[9370].Fix(VELOCITY_Y); -NODES[9370].Fix(VELOCITY_Z); -NODES[9380].Fix(VELOCITY_X); -NODES[9380].Fix(VELOCITY_Y); -NODES[9380].Fix(VELOCITY_Z); -NODES[9388].Fix(VELOCITY_X); -NODES[9388].Fix(VELOCITY_Y); -NODES[9388].Fix(VELOCITY_Z); -NODES[9394].Fix(VELOCITY_X); -NODES[9394].Fix(VELOCITY_Y); -NODES[9394].Fix(VELOCITY_Z); -NODES[9405].Fix(VELOCITY_X); -NODES[9405].Fix(VELOCITY_Y); -NODES[9405].Fix(VELOCITY_Z); -NODES[9422].Fix(VELOCITY_X); -NODES[9422].Fix(VELOCITY_Y); -NODES[9422].Fix(VELOCITY_Z); -NODES[9423].Fix(VELOCITY_X); -NODES[9423].Fix(VELOCITY_Y); -NODES[9423].Fix(VELOCITY_Z); -NODES[9425].Fix(VELOCITY_X); -NODES[9425].Fix(VELOCITY_Y); -NODES[9425].Fix(VELOCITY_Z); -NODES[9432].Fix(VELOCITY_X); -NODES[9432].Fix(VELOCITY_Y); -NODES[9432].Fix(VELOCITY_Z); -NODES[9435].Fix(VELOCITY_X); -NODES[9435].Fix(VELOCITY_Y); -NODES[9435].Fix(VELOCITY_Z); -NODES[9436].Fix(VELOCITY_X); -NODES[9436].Fix(VELOCITY_Y); -NODES[9436].Fix(VELOCITY_Z); -NODES[9449].Fix(VELOCITY_X); -NODES[9449].Fix(VELOCITY_Y); -NODES[9449].Fix(VELOCITY_Z); -NODES[9450].Fix(VELOCITY_X); -NODES[9450].Fix(VELOCITY_Y); -NODES[9450].Fix(VELOCITY_Z); -NODES[9453].Fix(VELOCITY_X); -NODES[9453].Fix(VELOCITY_Y); -NODES[9453].Fix(VELOCITY_Z); -NODES[9454].Fix(VELOCITY_X); -NODES[9454].Fix(VELOCITY_Y); -NODES[9454].Fix(VELOCITY_Z); -NODES[9490].Fix(VELOCITY_X); -NODES[9490].Fix(VELOCITY_Y); -NODES[9490].Fix(VELOCITY_Z); -NODES[9494].Fix(VELOCITY_X); -NODES[9494].Fix(VELOCITY_Y); -NODES[9494].Fix(VELOCITY_Z); -NODES[9496].Fix(VELOCITY_X); -NODES[9496].Fix(VELOCITY_Y); -NODES[9496].Fix(VELOCITY_Z); -NODES[9497].Fix(VELOCITY_X); -NODES[9497].Fix(VELOCITY_Y); -NODES[9497].Fix(VELOCITY_Z); -NODES[9507].Fix(VELOCITY_X); -NODES[9507].Fix(VELOCITY_Y); -NODES[9507].Fix(VELOCITY_Z); -NODES[9515].Fix(VELOCITY_X); -NODES[9515].Fix(VELOCITY_Y); -NODES[9515].Fix(VELOCITY_Z); -NODES[9521].Fix(VELOCITY_X); -NODES[9521].Fix(VELOCITY_Y); -NODES[9521].Fix(VELOCITY_Z); -NODES[9522].Fix(VELOCITY_X); -NODES[9522].Fix(VELOCITY_Y); -NODES[9522].Fix(VELOCITY_Z); -NODES[9523].Fix(VELOCITY_X); -NODES[9523].Fix(VELOCITY_Y); -NODES[9523].Fix(VELOCITY_Z); -NODES[9524].Fix(VELOCITY_X); -NODES[9524].Fix(VELOCITY_Y); -NODES[9524].Fix(VELOCITY_Z); -NODES[9525].Fix(VELOCITY_X); -NODES[9525].Fix(VELOCITY_Y); -NODES[9525].Fix(VELOCITY_Z); -NODES[9526].Fix(VELOCITY_X); -NODES[9526].Fix(VELOCITY_Y); -NODES[9526].Fix(VELOCITY_Z); -NODES[9537].Fix(VELOCITY_X); -NODES[9537].Fix(VELOCITY_Y); -NODES[9537].Fix(VELOCITY_Z); -NODES[9539].Fix(VELOCITY_X); -NODES[9539].Fix(VELOCITY_Y); -NODES[9539].Fix(VELOCITY_Z); -NODES[9541].Fix(VELOCITY_X); -NODES[9541].Fix(VELOCITY_Y); -NODES[9541].Fix(VELOCITY_Z); -NODES[9547].Fix(VELOCITY_X); -NODES[9547].Fix(VELOCITY_Y); -NODES[9547].Fix(VELOCITY_Z); -NODES[9557].Fix(VELOCITY_X); -NODES[9557].Fix(VELOCITY_Y); -NODES[9557].Fix(VELOCITY_Z); -NODES[9558].Fix(VELOCITY_X); -NODES[9558].Fix(VELOCITY_Y); -NODES[9558].Fix(VELOCITY_Z); -NODES[9561].Fix(VELOCITY_X); -NODES[9561].Fix(VELOCITY_Y); -NODES[9561].Fix(VELOCITY_Z); -NODES[9562].Fix(VELOCITY_X); -NODES[9562].Fix(VELOCITY_Y); -NODES[9562].Fix(VELOCITY_Z); -NODES[9563].Fix(VELOCITY_X); -NODES[9563].Fix(VELOCITY_Y); -NODES[9563].Fix(VELOCITY_Z); -NODES[9578].Fix(VELOCITY_X); -NODES[9578].Fix(VELOCITY_Y); -NODES[9578].Fix(VELOCITY_Z); -NODES[9579].Fix(VELOCITY_X); -NODES[9579].Fix(VELOCITY_Y); -NODES[9579].Fix(VELOCITY_Z); -NODES[9580].Fix(VELOCITY_X); -NODES[9580].Fix(VELOCITY_Y); -NODES[9580].Fix(VELOCITY_Z); -NODES[9586].Fix(VELOCITY_X); -NODES[9586].Fix(VELOCITY_Y); -NODES[9586].Fix(VELOCITY_Z); -NODES[9600].Fix(VELOCITY_X); -NODES[9600].Fix(VELOCITY_Y); -NODES[9600].Fix(VELOCITY_Z); -NODES[9605].Fix(VELOCITY_X); -NODES[9605].Fix(VELOCITY_Y); -NODES[9605].Fix(VELOCITY_Z); -NODES[9606].Fix(VELOCITY_X); -NODES[9606].Fix(VELOCITY_Y); -NODES[9606].Fix(VELOCITY_Z); -NODES[9624].Fix(VELOCITY_X); -NODES[9624].Fix(VELOCITY_Y); -NODES[9624].Fix(VELOCITY_Z); -NODES[9625].Fix(VELOCITY_X); -NODES[9625].Fix(VELOCITY_Y); -NODES[9625].Fix(VELOCITY_Z); -NODES[9626].Fix(VELOCITY_X); -NODES[9626].Fix(VELOCITY_Y); -NODES[9626].Fix(VELOCITY_Z); -NODES[9632].Fix(VELOCITY_X); -NODES[9632].Fix(VELOCITY_Y); -NODES[9632].Fix(VELOCITY_Z); -NODES[9639].Fix(VELOCITY_X); -NODES[9639].Fix(VELOCITY_Y); -NODES[9639].Fix(VELOCITY_Z); -NODES[9643].Fix(VELOCITY_X); -NODES[9643].Fix(VELOCITY_Y); -NODES[9643].Fix(VELOCITY_Z); -NODES[9650].Fix(VELOCITY_X); -NODES[9650].Fix(VELOCITY_Y); -NODES[9650].Fix(VELOCITY_Z); -NODES[9651].Fix(VELOCITY_X); -NODES[9651].Fix(VELOCITY_Y); -NODES[9651].Fix(VELOCITY_Z); -NODES[9654].Fix(VELOCITY_X); -NODES[9654].Fix(VELOCITY_Y); -NODES[9654].Fix(VELOCITY_Z); -NODES[9656].Fix(VELOCITY_X); -NODES[9656].Fix(VELOCITY_Y); -NODES[9656].Fix(VELOCITY_Z); -NODES[9670].Fix(VELOCITY_X); -NODES[9670].Fix(VELOCITY_Y); -NODES[9670].Fix(VELOCITY_Z); -NODES[9671].Fix(VELOCITY_X); -NODES[9671].Fix(VELOCITY_Y); -NODES[9671].Fix(VELOCITY_Z); -NODES[9694].Fix(VELOCITY_X); -NODES[9694].Fix(VELOCITY_Y); -NODES[9694].Fix(VELOCITY_Z); -NODES[9700].Fix(VELOCITY_X); -NODES[9700].Fix(VELOCITY_Y); -NODES[9700].Fix(VELOCITY_Z); -NODES[9711].Fix(VELOCITY_X); -NODES[9711].Fix(VELOCITY_Y); -NODES[9711].Fix(VELOCITY_Z); -NODES[9716].Fix(VELOCITY_X); -NODES[9716].Fix(VELOCITY_Y); -NODES[9716].Fix(VELOCITY_Z); -NODES[9718].Fix(VELOCITY_X); -NODES[9718].Fix(VELOCITY_Y); -NODES[9718].Fix(VELOCITY_Z); -NODES[9719].Fix(VELOCITY_X); -NODES[9719].Fix(VELOCITY_Y); -NODES[9719].Fix(VELOCITY_Z); -NODES[9721].Fix(VELOCITY_X); -NODES[9721].Fix(VELOCITY_Y); -NODES[9721].Fix(VELOCITY_Z); -NODES[9726].Fix(VELOCITY_X); -NODES[9726].Fix(VELOCITY_Y); -NODES[9726].Fix(VELOCITY_Z); -NODES[9727].Fix(VELOCITY_X); -NODES[9727].Fix(VELOCITY_Y); -NODES[9727].Fix(VELOCITY_Z); -NODES[9728].Fix(VELOCITY_X); -NODES[9728].Fix(VELOCITY_Y); -NODES[9728].Fix(VELOCITY_Z); -NODES[9729].Fix(VELOCITY_X); -NODES[9729].Fix(VELOCITY_Y); -NODES[9729].Fix(VELOCITY_Z); -NODES[9730].Fix(VELOCITY_X); -NODES[9730].Fix(VELOCITY_Y); -NODES[9730].Fix(VELOCITY_Z); -NODES[9731].Fix(VELOCITY_X); -NODES[9731].Fix(VELOCITY_Y); -NODES[9731].Fix(VELOCITY_Z); -NODES[9732].Fix(VELOCITY_X); -NODES[9732].Fix(VELOCITY_Y); -NODES[9732].Fix(VELOCITY_Z); -NODES[9736].Fix(VELOCITY_X); -NODES[9736].Fix(VELOCITY_Y); -NODES[9736].Fix(VELOCITY_Z); -NODES[9737].Fix(VELOCITY_X); -NODES[9737].Fix(VELOCITY_Y); -NODES[9737].Fix(VELOCITY_Z); -NODES[9739].Fix(VELOCITY_X); -NODES[9739].Fix(VELOCITY_Y); -NODES[9739].Fix(VELOCITY_Z); -NODES[9740].Fix(VELOCITY_X); -NODES[9740].Fix(VELOCITY_Y); -NODES[9740].Fix(VELOCITY_Z); -NODES[9742].Fix(VELOCITY_X); -NODES[9742].Fix(VELOCITY_Y); -NODES[9742].Fix(VELOCITY_Z); -NODES[9743].Fix(VELOCITY_X); -NODES[9743].Fix(VELOCITY_Y); -NODES[9743].Fix(VELOCITY_Z); -NODES[9746].Fix(VELOCITY_X); -NODES[9746].Fix(VELOCITY_Y); -NODES[9746].Fix(VELOCITY_Z); -NODES[9749].Fix(VELOCITY_X); -NODES[9749].Fix(VELOCITY_Y); -NODES[9749].Fix(VELOCITY_Z); -NODES[9750].Fix(VELOCITY_X); -NODES[9750].Fix(VELOCITY_Y); -NODES[9750].Fix(VELOCITY_Z); -NODES[9757].Fix(VELOCITY_X); -NODES[9757].Fix(VELOCITY_Y); -NODES[9757].Fix(VELOCITY_Z); -NODES[9759].Fix(VELOCITY_X); -NODES[9759].Fix(VELOCITY_Y); -NODES[9759].Fix(VELOCITY_Z); -NODES[9763].Fix(VELOCITY_X); -NODES[9763].Fix(VELOCITY_Y); -NODES[9763].Fix(VELOCITY_Z); -NODES[9765].Fix(VELOCITY_X); -NODES[9765].Fix(VELOCITY_Y); -NODES[9765].Fix(VELOCITY_Z); -NODES[9767].Fix(VELOCITY_X); -NODES[9767].Fix(VELOCITY_Y); -NODES[9767].Fix(VELOCITY_Z); -NODES[9768].Fix(VELOCITY_X); -NODES[9768].Fix(VELOCITY_Y); -NODES[9768].Fix(VELOCITY_Z); -NODES[9769].Fix(VELOCITY_X); -NODES[9769].Fix(VELOCITY_Y); -NODES[9769].Fix(VELOCITY_Z); -NODES[9778].Fix(VELOCITY_X); -NODES[9778].Fix(VELOCITY_Y); -NODES[9778].Fix(VELOCITY_Z); -NODES[9783].Fix(VELOCITY_X); -NODES[9783].Fix(VELOCITY_Y); -NODES[9783].Fix(VELOCITY_Z); -NODES[9784].Fix(VELOCITY_X); -NODES[9784].Fix(VELOCITY_Y); -NODES[9784].Fix(VELOCITY_Z); -NODES[9789].Fix(VELOCITY_X); -NODES[9789].Fix(VELOCITY_Y); -NODES[9789].Fix(VELOCITY_Z); -NODES[9805].Fix(VELOCITY_X); -NODES[9805].Fix(VELOCITY_Y); -NODES[9805].Fix(VELOCITY_Z); -NODES[9810].Fix(VELOCITY_X); -NODES[9810].Fix(VELOCITY_Y); -NODES[9810].Fix(VELOCITY_Z); -NODES[9814].Fix(VELOCITY_X); -NODES[9814].Fix(VELOCITY_Y); -NODES[9814].Fix(VELOCITY_Z); -NODES[9829].Fix(VELOCITY_X); -NODES[9829].Fix(VELOCITY_Y); -NODES[9829].Fix(VELOCITY_Z); -NODES[9830].Fix(VELOCITY_X); -NODES[9830].Fix(VELOCITY_Y); -NODES[9830].Fix(VELOCITY_Z); -NODES[9831].Fix(VELOCITY_X); -NODES[9831].Fix(VELOCITY_Y); -NODES[9831].Fix(VELOCITY_Z); -NODES[9841].Fix(VELOCITY_X); -NODES[9841].Fix(VELOCITY_Y); -NODES[9841].Fix(VELOCITY_Z); -NODES[9842].Fix(VELOCITY_X); -NODES[9842].Fix(VELOCITY_Y); -NODES[9842].Fix(VELOCITY_Z); -NODES[9843].Fix(VELOCITY_X); -NODES[9843].Fix(VELOCITY_Y); -NODES[9843].Fix(VELOCITY_Z); -NODES[9844].Fix(VELOCITY_X); -NODES[9844].Fix(VELOCITY_Y); -NODES[9844].Fix(VELOCITY_Z); -NODES[9861].Fix(VELOCITY_X); -NODES[9861].Fix(VELOCITY_Y); -NODES[9861].Fix(VELOCITY_Z); -NODES[9864].Fix(VELOCITY_X); -NODES[9864].Fix(VELOCITY_Y); -NODES[9864].Fix(VELOCITY_Z); -NODES[9867].Fix(VELOCITY_X); -NODES[9867].Fix(VELOCITY_Y); -NODES[9867].Fix(VELOCITY_Z); -NODES[9868].Fix(VELOCITY_X); -NODES[9868].Fix(VELOCITY_Y); -NODES[9868].Fix(VELOCITY_Z); -NODES[9873].Fix(VELOCITY_X); -NODES[9873].Fix(VELOCITY_Y); -NODES[9873].Fix(VELOCITY_Z); -NODES[9874].Fix(VELOCITY_X); -NODES[9874].Fix(VELOCITY_Y); -NODES[9874].Fix(VELOCITY_Z); -NODES[9878].Fix(VELOCITY_X); -NODES[9878].Fix(VELOCITY_Y); -NODES[9878].Fix(VELOCITY_Z); -NODES[9879].Fix(VELOCITY_X); -NODES[9879].Fix(VELOCITY_Y); -NODES[9879].Fix(VELOCITY_Z); -NODES[9880].Fix(VELOCITY_X); -NODES[9880].Fix(VELOCITY_Y); -NODES[9880].Fix(VELOCITY_Z); -NODES[9881].Fix(VELOCITY_X); -NODES[9881].Fix(VELOCITY_Y); -NODES[9881].Fix(VELOCITY_Z); -NODES[9891].Fix(VELOCITY_X); -NODES[9891].Fix(VELOCITY_Y); -NODES[9891].Fix(VELOCITY_Z); -NODES[9897].Fix(VELOCITY_X); -NODES[9897].Fix(VELOCITY_Y); -NODES[9897].Fix(VELOCITY_Z); -NODES[9900].Fix(VELOCITY_X); -NODES[9900].Fix(VELOCITY_Y); -NODES[9900].Fix(VELOCITY_Z); -NODES[9915].Fix(VELOCITY_X); -NODES[9915].Fix(VELOCITY_Y); -NODES[9915].Fix(VELOCITY_Z); -NODES[9916].Fix(VELOCITY_X); -NODES[9916].Fix(VELOCITY_Y); -NODES[9916].Fix(VELOCITY_Z); -NODES[9921].Fix(VELOCITY_X); -NODES[9921].Fix(VELOCITY_Y); -NODES[9921].Fix(VELOCITY_Z); -NODES[9926].Fix(VELOCITY_X); -NODES[9926].Fix(VELOCITY_Y); -NODES[9926].Fix(VELOCITY_Z); -NODES[9930].Fix(VELOCITY_X); -NODES[9930].Fix(VELOCITY_Y); -NODES[9930].Fix(VELOCITY_Z); -NODES[9937].Fix(VELOCITY_X); -NODES[9937].Fix(VELOCITY_Y); -NODES[9937].Fix(VELOCITY_Z); -NODES[9938].Fix(VELOCITY_X); -NODES[9938].Fix(VELOCITY_Y); -NODES[9938].Fix(VELOCITY_Z); -NODES[9939].Fix(VELOCITY_X); -NODES[9939].Fix(VELOCITY_Y); -NODES[9939].Fix(VELOCITY_Z); -NODES[9946].Fix(VELOCITY_X); -NODES[9946].Fix(VELOCITY_Y); -NODES[9946].Fix(VELOCITY_Z); -NODES[9947].Fix(VELOCITY_X); -NODES[9947].Fix(VELOCITY_Y); -NODES[9947].Fix(VELOCITY_Z); -NODES[9948].Fix(VELOCITY_X); -NODES[9948].Fix(VELOCITY_Y); -NODES[9948].Fix(VELOCITY_Z); -NODES[9964].Fix(VELOCITY_X); -NODES[9964].Fix(VELOCITY_Y); -NODES[9964].Fix(VELOCITY_Z); -NODES[9975].Fix(VELOCITY_X); -NODES[9975].Fix(VELOCITY_Y); -NODES[9975].Fix(VELOCITY_Z); -NODES[9976].Fix(VELOCITY_X); -NODES[9976].Fix(VELOCITY_Y); -NODES[9976].Fix(VELOCITY_Z); -NODES[9978].Fix(VELOCITY_X); -NODES[9978].Fix(VELOCITY_Y); -NODES[9978].Fix(VELOCITY_Z); -NODES[9979].Fix(VELOCITY_X); -NODES[9979].Fix(VELOCITY_Y); -NODES[9979].Fix(VELOCITY_Z); -NODES[9981].Fix(VELOCITY_X); -NODES[9981].Fix(VELOCITY_Y); -NODES[9981].Fix(VELOCITY_Z); -NODES[9987].Fix(VELOCITY_X); -NODES[9987].Fix(VELOCITY_Y); -NODES[9987].Fix(VELOCITY_Z); -NODES[9988].Fix(VELOCITY_X); -NODES[9988].Fix(VELOCITY_Y); -NODES[9988].Fix(VELOCITY_Z); -NODES[9989].Fix(VELOCITY_X); -NODES[9989].Fix(VELOCITY_Y); -NODES[9989].Fix(VELOCITY_Z); -NODES[10011].Fix(VELOCITY_X); -NODES[10011].Fix(VELOCITY_Y); -NODES[10011].Fix(VELOCITY_Z); -NODES[10024].Fix(VELOCITY_X); -NODES[10024].Fix(VELOCITY_Y); -NODES[10024].Fix(VELOCITY_Z); -NODES[10025].Fix(VELOCITY_X); -NODES[10025].Fix(VELOCITY_Y); -NODES[10025].Fix(VELOCITY_Z); -NODES[10032].Fix(VELOCITY_X); -NODES[10032].Fix(VELOCITY_Y); -NODES[10032].Fix(VELOCITY_Z); -NODES[10039].Fix(VELOCITY_X); -NODES[10039].Fix(VELOCITY_Y); -NODES[10039].Fix(VELOCITY_Z); -NODES[10045].Fix(VELOCITY_X); -NODES[10045].Fix(VELOCITY_Y); -NODES[10045].Fix(VELOCITY_Z); -NODES[10046].Fix(VELOCITY_X); -NODES[10046].Fix(VELOCITY_Y); -NODES[10046].Fix(VELOCITY_Z); -NODES[10047].Fix(VELOCITY_X); -NODES[10047].Fix(VELOCITY_Y); -NODES[10047].Fix(VELOCITY_Z); -NODES[10052].Fix(VELOCITY_X); -NODES[10052].Fix(VELOCITY_Y); -NODES[10052].Fix(VELOCITY_Z); -NODES[10053].Fix(VELOCITY_X); -NODES[10053].Fix(VELOCITY_Y); -NODES[10053].Fix(VELOCITY_Z); -NODES[10060].Fix(VELOCITY_X); -NODES[10060].Fix(VELOCITY_Y); -NODES[10060].Fix(VELOCITY_Z); -NODES[10062].Fix(VELOCITY_X); -NODES[10062].Fix(VELOCITY_Y); -NODES[10062].Fix(VELOCITY_Z); -NODES[10063].Fix(VELOCITY_X); -NODES[10063].Fix(VELOCITY_Y); -NODES[10063].Fix(VELOCITY_Z); -NODES[10064].Fix(VELOCITY_X); -NODES[10064].Fix(VELOCITY_Y); -NODES[10064].Fix(VELOCITY_Z); -NODES[10067].Fix(VELOCITY_X); -NODES[10067].Fix(VELOCITY_Y); -NODES[10067].Fix(VELOCITY_Z); -NODES[10075].Fix(VELOCITY_X); -NODES[10075].Fix(VELOCITY_Y); -NODES[10075].Fix(VELOCITY_Z); -NODES[10081].Fix(VELOCITY_X); -NODES[10081].Fix(VELOCITY_Y); -NODES[10081].Fix(VELOCITY_Z); -NODES[10083].Fix(VELOCITY_X); -NODES[10083].Fix(VELOCITY_Y); -NODES[10083].Fix(VELOCITY_Z); -NODES[10095].Fix(VELOCITY_X); -NODES[10095].Fix(VELOCITY_Y); -NODES[10095].Fix(VELOCITY_Z); -NODES[10101].Fix(VELOCITY_X); -NODES[10101].Fix(VELOCITY_Y); -NODES[10101].Fix(VELOCITY_Z); -NODES[10111].Fix(VELOCITY_X); -NODES[10111].Fix(VELOCITY_Y); -NODES[10111].Fix(VELOCITY_Z); -NODES[10124].Fix(VELOCITY_X); -NODES[10124].Fix(VELOCITY_Y); -NODES[10124].Fix(VELOCITY_Z); -NODES[10125].Fix(VELOCITY_X); -NODES[10125].Fix(VELOCITY_Y); -NODES[10125].Fix(VELOCITY_Z); -NODES[10129].Fix(VELOCITY_X); -NODES[10129].Fix(VELOCITY_Y); -NODES[10129].Fix(VELOCITY_Z); -NODES[10136].Fix(VELOCITY_X); -NODES[10136].Fix(VELOCITY_Y); -NODES[10136].Fix(VELOCITY_Z); -NODES[10139].Fix(VELOCITY_X); -NODES[10139].Fix(VELOCITY_Y); -NODES[10139].Fix(VELOCITY_Z); -NODES[10140].Fix(VELOCITY_X); -NODES[10140].Fix(VELOCITY_Y); -NODES[10140].Fix(VELOCITY_Z); -NODES[10141].Fix(VELOCITY_X); -NODES[10141].Fix(VELOCITY_Y); -NODES[10141].Fix(VELOCITY_Z); -NODES[10150].Fix(VELOCITY_X); -NODES[10150].Fix(VELOCITY_Y); -NODES[10150].Fix(VELOCITY_Z); -NODES[10151].Fix(VELOCITY_X); -NODES[10151].Fix(VELOCITY_Y); -NODES[10151].Fix(VELOCITY_Z); -NODES[10161].Fix(VELOCITY_X); -NODES[10161].Fix(VELOCITY_Y); -NODES[10161].Fix(VELOCITY_Z); -NODES[10162].Fix(VELOCITY_X); -NODES[10162].Fix(VELOCITY_Y); -NODES[10162].Fix(VELOCITY_Z); -NODES[10163].Fix(VELOCITY_X); -NODES[10163].Fix(VELOCITY_Y); -NODES[10163].Fix(VELOCITY_Z); -NODES[10164].Fix(VELOCITY_X); -NODES[10164].Fix(VELOCITY_Y); -NODES[10164].Fix(VELOCITY_Z); -NODES[10165].Fix(VELOCITY_X); -NODES[10165].Fix(VELOCITY_Y); -NODES[10165].Fix(VELOCITY_Z); -NODES[10166].Fix(VELOCITY_X); -NODES[10166].Fix(VELOCITY_Y); -NODES[10166].Fix(VELOCITY_Z); -NODES[10172].Fix(VELOCITY_X); -NODES[10172].Fix(VELOCITY_Y); -NODES[10172].Fix(VELOCITY_Z); -NODES[10175].Fix(VELOCITY_X); -NODES[10175].Fix(VELOCITY_Y); -NODES[10175].Fix(VELOCITY_Z); -NODES[10176].Fix(VELOCITY_X); -NODES[10176].Fix(VELOCITY_Y); -NODES[10176].Fix(VELOCITY_Z); -NODES[10177].Fix(VELOCITY_X); -NODES[10177].Fix(VELOCITY_Y); -NODES[10177].Fix(VELOCITY_Z); -NODES[10183].Fix(VELOCITY_X); -NODES[10183].Fix(VELOCITY_Y); -NODES[10183].Fix(VELOCITY_Z); -NODES[10189].Fix(VELOCITY_X); -NODES[10189].Fix(VELOCITY_Y); -NODES[10189].Fix(VELOCITY_Z); -NODES[10196].Fix(VELOCITY_X); -NODES[10196].Fix(VELOCITY_Y); -NODES[10196].Fix(VELOCITY_Z); -NODES[10197].Fix(VELOCITY_X); -NODES[10197].Fix(VELOCITY_Y); -NODES[10197].Fix(VELOCITY_Z); -NODES[10198].Fix(VELOCITY_X); -NODES[10198].Fix(VELOCITY_Y); -NODES[10198].Fix(VELOCITY_Z); -NODES[10201].Fix(VELOCITY_X); -NODES[10201].Fix(VELOCITY_Y); -NODES[10201].Fix(VELOCITY_Z); -NODES[10203].Fix(VELOCITY_X); -NODES[10203].Fix(VELOCITY_Y); -NODES[10203].Fix(VELOCITY_Z); -NODES[10204].Fix(VELOCITY_X); -NODES[10204].Fix(VELOCITY_Y); -NODES[10204].Fix(VELOCITY_Z); -NODES[10223].Fix(VELOCITY_X); -NODES[10223].Fix(VELOCITY_Y); -NODES[10223].Fix(VELOCITY_Z); -NODES[10226].Fix(VELOCITY_X); -NODES[10226].Fix(VELOCITY_Y); -NODES[10226].Fix(VELOCITY_Z); -NODES[10227].Fix(VELOCITY_X); -NODES[10227].Fix(VELOCITY_Y); -NODES[10227].Fix(VELOCITY_Z); -NODES[10237].Fix(VELOCITY_X); -NODES[10237].Fix(VELOCITY_Y); -NODES[10237].Fix(VELOCITY_Z); -NODES[10246].Fix(VELOCITY_X); -NODES[10246].Fix(VELOCITY_Y); -NODES[10246].Fix(VELOCITY_Z); -NODES[10247].Fix(VELOCITY_X); -NODES[10247].Fix(VELOCITY_Y); -NODES[10247].Fix(VELOCITY_Z); -NODES[10251].Fix(VELOCITY_X); -NODES[10251].Fix(VELOCITY_Y); -NODES[10251].Fix(VELOCITY_Z); -NODES[10253].Fix(VELOCITY_X); -NODES[10253].Fix(VELOCITY_Y); -NODES[10253].Fix(VELOCITY_Z); -NODES[10259].Fix(VELOCITY_X); -NODES[10259].Fix(VELOCITY_Y); -NODES[10259].Fix(VELOCITY_Z); -NODES[10279].Fix(VELOCITY_X); -NODES[10279].Fix(VELOCITY_Y); -NODES[10279].Fix(VELOCITY_Z); -NODES[10280].Fix(VELOCITY_X); -NODES[10280].Fix(VELOCITY_Y); -NODES[10280].Fix(VELOCITY_Z); -NODES[10285].Fix(VELOCITY_X); -NODES[10285].Fix(VELOCITY_Y); -NODES[10285].Fix(VELOCITY_Z); -NODES[10286].Fix(VELOCITY_X); -NODES[10286].Fix(VELOCITY_Y); -NODES[10286].Fix(VELOCITY_Z); -NODES[10300].Fix(VELOCITY_X); -NODES[10300].Fix(VELOCITY_Y); -NODES[10300].Fix(VELOCITY_Z); -NODES[10301].Fix(VELOCITY_X); -NODES[10301].Fix(VELOCITY_Y); -NODES[10301].Fix(VELOCITY_Z); -NODES[10311].Fix(VELOCITY_X); -NODES[10311].Fix(VELOCITY_Y); -NODES[10311].Fix(VELOCITY_Z); -NODES[10312].Fix(VELOCITY_X); -NODES[10312].Fix(VELOCITY_Y); -NODES[10312].Fix(VELOCITY_Z); -NODES[10315].Fix(VELOCITY_X); -NODES[10315].Fix(VELOCITY_Y); -NODES[10315].Fix(VELOCITY_Z); -NODES[10328].Fix(VELOCITY_X); -NODES[10328].Fix(VELOCITY_Y); -NODES[10328].Fix(VELOCITY_Z); -NODES[10331].Fix(VELOCITY_X); -NODES[10331].Fix(VELOCITY_Y); -NODES[10331].Fix(VELOCITY_Z); -NODES[10332].Fix(VELOCITY_X); -NODES[10332].Fix(VELOCITY_Y); -NODES[10332].Fix(VELOCITY_Z); -NODES[10334].Fix(VELOCITY_X); -NODES[10334].Fix(VELOCITY_Y); -NODES[10334].Fix(VELOCITY_Z); -NODES[10341].Fix(VELOCITY_X); -NODES[10341].Fix(VELOCITY_Y); -NODES[10341].Fix(VELOCITY_Z); -NODES[10342].Fix(VELOCITY_X); -NODES[10342].Fix(VELOCITY_Y); -NODES[10342].Fix(VELOCITY_Z); -NODES[10348].Fix(VELOCITY_X); -NODES[10348].Fix(VELOCITY_Y); -NODES[10348].Fix(VELOCITY_Z); -NODES[10353].Fix(VELOCITY_X); -NODES[10353].Fix(VELOCITY_Y); -NODES[10353].Fix(VELOCITY_Z); -NODES[10355].Fix(VELOCITY_X); -NODES[10355].Fix(VELOCITY_Y); -NODES[10355].Fix(VELOCITY_Z); -NODES[10375].Fix(VELOCITY_X); -NODES[10375].Fix(VELOCITY_Y); -NODES[10375].Fix(VELOCITY_Z); -NODES[10379].Fix(VELOCITY_X); -NODES[10379].Fix(VELOCITY_Y); -NODES[10379].Fix(VELOCITY_Z); -NODES[10380].Fix(VELOCITY_X); -NODES[10380].Fix(VELOCITY_Y); -NODES[10380].Fix(VELOCITY_Z); -NODES[10385].Fix(VELOCITY_X); -NODES[10385].Fix(VELOCITY_Y); -NODES[10385].Fix(VELOCITY_Z); -NODES[10395].Fix(VELOCITY_X); -NODES[10395].Fix(VELOCITY_Y); -NODES[10395].Fix(VELOCITY_Z); -NODES[10411].Fix(VELOCITY_X); -NODES[10411].Fix(VELOCITY_Y); -NODES[10411].Fix(VELOCITY_Z); -NODES[10412].Fix(VELOCITY_X); -NODES[10412].Fix(VELOCITY_Y); -NODES[10412].Fix(VELOCITY_Z); -NODES[10415].Fix(VELOCITY_X); -NODES[10415].Fix(VELOCITY_Y); -NODES[10415].Fix(VELOCITY_Z); -NODES[10416].Fix(VELOCITY_X); -NODES[10416].Fix(VELOCITY_Y); -NODES[10416].Fix(VELOCITY_Z); -NODES[10417].Fix(VELOCITY_X); -NODES[10417].Fix(VELOCITY_Y); -NODES[10417].Fix(VELOCITY_Z); -NODES[10418].Fix(VELOCITY_X); -NODES[10418].Fix(VELOCITY_Y); -NODES[10418].Fix(VELOCITY_Z); -NODES[10423].Fix(VELOCITY_X); -NODES[10423].Fix(VELOCITY_Y); -NODES[10423].Fix(VELOCITY_Z); -NODES[10444].Fix(VELOCITY_X); -NODES[10444].Fix(VELOCITY_Y); -NODES[10444].Fix(VELOCITY_Z); -NODES[10445].Fix(VELOCITY_X); -NODES[10445].Fix(VELOCITY_Y); -NODES[10445].Fix(VELOCITY_Z); -NODES[10460].Fix(VELOCITY_X); -NODES[10460].Fix(VELOCITY_Y); -NODES[10460].Fix(VELOCITY_Z); -NODES[10481].Fix(VELOCITY_X); -NODES[10481].Fix(VELOCITY_Y); -NODES[10481].Fix(VELOCITY_Z); -NODES[10485].Fix(VELOCITY_X); -NODES[10485].Fix(VELOCITY_Y); -NODES[10485].Fix(VELOCITY_Z); -NODES[10489].Fix(VELOCITY_X); -NODES[10489].Fix(VELOCITY_Y); -NODES[10489].Fix(VELOCITY_Z); -NODES[10490].Fix(VELOCITY_X); -NODES[10490].Fix(VELOCITY_Y); -NODES[10490].Fix(VELOCITY_Z); -NODES[10491].Fix(VELOCITY_X); -NODES[10491].Fix(VELOCITY_Y); -NODES[10491].Fix(VELOCITY_Z); -NODES[10499].Fix(VELOCITY_X); -NODES[10499].Fix(VELOCITY_Y); -NODES[10499].Fix(VELOCITY_Z); -NODES[10505].Fix(VELOCITY_X); -NODES[10505].Fix(VELOCITY_Y); -NODES[10505].Fix(VELOCITY_Z); -NODES[10507].Fix(VELOCITY_X); -NODES[10507].Fix(VELOCITY_Y); -NODES[10507].Fix(VELOCITY_Z); -NODES[10508].Fix(VELOCITY_X); -NODES[10508].Fix(VELOCITY_Y); -NODES[10508].Fix(VELOCITY_Z); -NODES[10510].Fix(VELOCITY_X); -NODES[10510].Fix(VELOCITY_Y); -NODES[10510].Fix(VELOCITY_Z); -NODES[10513].Fix(VELOCITY_X); -NODES[10513].Fix(VELOCITY_Y); -NODES[10513].Fix(VELOCITY_Z); -NODES[10517].Fix(VELOCITY_X); -NODES[10517].Fix(VELOCITY_Y); -NODES[10517].Fix(VELOCITY_Z); -NODES[10518].Fix(VELOCITY_X); -NODES[10518].Fix(VELOCITY_Y); -NODES[10518].Fix(VELOCITY_Z); -NODES[10519].Fix(VELOCITY_X); -NODES[10519].Fix(VELOCITY_Y); -NODES[10519].Fix(VELOCITY_Z); -NODES[10521].Fix(VELOCITY_X); -NODES[10521].Fix(VELOCITY_Y); -NODES[10521].Fix(VELOCITY_Z); -NODES[10522].Fix(VELOCITY_X); -NODES[10522].Fix(VELOCITY_Y); -NODES[10522].Fix(VELOCITY_Z); -NODES[10523].Fix(VELOCITY_X); -NODES[10523].Fix(VELOCITY_Y); -NODES[10523].Fix(VELOCITY_Z); -NODES[10532].Fix(VELOCITY_X); -NODES[10532].Fix(VELOCITY_Y); -NODES[10532].Fix(VELOCITY_Z); -NODES[10547].Fix(VELOCITY_X); -NODES[10547].Fix(VELOCITY_Y); -NODES[10547].Fix(VELOCITY_Z); -NODES[10554].Fix(VELOCITY_X); -NODES[10554].Fix(VELOCITY_Y); -NODES[10554].Fix(VELOCITY_Z); -NODES[10565].Fix(VELOCITY_X); -NODES[10565].Fix(VELOCITY_Y); -NODES[10565].Fix(VELOCITY_Z); -NODES[10574].Fix(VELOCITY_X); -NODES[10574].Fix(VELOCITY_Y); -NODES[10574].Fix(VELOCITY_Z); -NODES[10578].Fix(VELOCITY_X); -NODES[10578].Fix(VELOCITY_Y); -NODES[10578].Fix(VELOCITY_Z); -NODES[10583].Fix(VELOCITY_X); -NODES[10583].Fix(VELOCITY_Y); -NODES[10583].Fix(VELOCITY_Z); -NODES[10584].Fix(VELOCITY_X); -NODES[10584].Fix(VELOCITY_Y); -NODES[10584].Fix(VELOCITY_Z); -NODES[10585].Fix(VELOCITY_X); -NODES[10585].Fix(VELOCITY_Y); -NODES[10585].Fix(VELOCITY_Z); -NODES[10588].Fix(VELOCITY_X); -NODES[10588].Fix(VELOCITY_Y); -NODES[10588].Fix(VELOCITY_Z); -NODES[10589].Fix(VELOCITY_X); -NODES[10589].Fix(VELOCITY_Y); -NODES[10589].Fix(VELOCITY_Z); -NODES[10598].Fix(VELOCITY_X); -NODES[10598].Fix(VELOCITY_Y); -NODES[10598].Fix(VELOCITY_Z); -NODES[10607].Fix(VELOCITY_X); -NODES[10607].Fix(VELOCITY_Y); -NODES[10607].Fix(VELOCITY_Z); -NODES[10608].Fix(VELOCITY_X); -NODES[10608].Fix(VELOCITY_Y); -NODES[10608].Fix(VELOCITY_Z); -NODES[10609].Fix(VELOCITY_X); -NODES[10609].Fix(VELOCITY_Y); -NODES[10609].Fix(VELOCITY_Z); -NODES[10610].Fix(VELOCITY_X); -NODES[10610].Fix(VELOCITY_Y); -NODES[10610].Fix(VELOCITY_Z); -NODES[10611].Fix(VELOCITY_X); -NODES[10611].Fix(VELOCITY_Y); -NODES[10611].Fix(VELOCITY_Z); -NODES[10616].Fix(VELOCITY_X); -NODES[10616].Fix(VELOCITY_Y); -NODES[10616].Fix(VELOCITY_Z); -NODES[10617].Fix(VELOCITY_X); -NODES[10617].Fix(VELOCITY_Y); -NODES[10617].Fix(VELOCITY_Z); -NODES[10620].Fix(VELOCITY_X); -NODES[10620].Fix(VELOCITY_Y); -NODES[10620].Fix(VELOCITY_Z); -NODES[10643].Fix(VELOCITY_X); -NODES[10643].Fix(VELOCITY_Y); -NODES[10643].Fix(VELOCITY_Z); -NODES[10644].Fix(VELOCITY_X); -NODES[10644].Fix(VELOCITY_Y); -NODES[10644].Fix(VELOCITY_Z); -NODES[10645].Fix(VELOCITY_X); -NODES[10645].Fix(VELOCITY_Y); -NODES[10645].Fix(VELOCITY_Z); -NODES[10646].Fix(VELOCITY_X); -NODES[10646].Fix(VELOCITY_Y); -NODES[10646].Fix(VELOCITY_Z); -NODES[10647].Fix(VELOCITY_X); -NODES[10647].Fix(VELOCITY_Y); -NODES[10647].Fix(VELOCITY_Z); -NODES[10648].Fix(VELOCITY_X); -NODES[10648].Fix(VELOCITY_Y); -NODES[10648].Fix(VELOCITY_Z); -NODES[10649].Fix(VELOCITY_X); -NODES[10649].Fix(VELOCITY_Y); -NODES[10649].Fix(VELOCITY_Z); -NODES[10650].Fix(VELOCITY_X); -NODES[10650].Fix(VELOCITY_Y); -NODES[10650].Fix(VELOCITY_Z); -NODES[10654].Fix(VELOCITY_X); -NODES[10654].Fix(VELOCITY_Y); -NODES[10654].Fix(VELOCITY_Z); -NODES[10663].Fix(VELOCITY_X); -NODES[10663].Fix(VELOCITY_Y); -NODES[10663].Fix(VELOCITY_Z); -NODES[10665].Fix(VELOCITY_X); -NODES[10665].Fix(VELOCITY_Y); -NODES[10665].Fix(VELOCITY_Z); -NODES[10667].Fix(VELOCITY_X); -NODES[10667].Fix(VELOCITY_Y); -NODES[10667].Fix(VELOCITY_Z); -NODES[10682].Fix(VELOCITY_X); -NODES[10682].Fix(VELOCITY_Y); -NODES[10682].Fix(VELOCITY_Z); -NODES[10683].Fix(VELOCITY_X); -NODES[10683].Fix(VELOCITY_Y); -NODES[10683].Fix(VELOCITY_Z); -NODES[10684].Fix(VELOCITY_X); -NODES[10684].Fix(VELOCITY_Y); -NODES[10684].Fix(VELOCITY_Z); -NODES[10685].Fix(VELOCITY_X); -NODES[10685].Fix(VELOCITY_Y); -NODES[10685].Fix(VELOCITY_Z); -NODES[10687].Fix(VELOCITY_X); -NODES[10687].Fix(VELOCITY_Y); -NODES[10687].Fix(VELOCITY_Z); -NODES[10691].Fix(VELOCITY_X); -NODES[10691].Fix(VELOCITY_Y); -NODES[10691].Fix(VELOCITY_Z); -NODES[10692].Fix(VELOCITY_X); -NODES[10692].Fix(VELOCITY_Y); -NODES[10692].Fix(VELOCITY_Z); -NODES[10693].Fix(VELOCITY_X); -NODES[10693].Fix(VELOCITY_Y); -NODES[10693].Fix(VELOCITY_Z); -NODES[10694].Fix(VELOCITY_X); -NODES[10694].Fix(VELOCITY_Y); -NODES[10694].Fix(VELOCITY_Z); -NODES[10710].Fix(VELOCITY_X); -NODES[10710].Fix(VELOCITY_Y); -NODES[10710].Fix(VELOCITY_Z); -NODES[10715].Fix(VELOCITY_X); -NODES[10715].Fix(VELOCITY_Y); -NODES[10715].Fix(VELOCITY_Z); -NODES[10721].Fix(VELOCITY_X); -NODES[10721].Fix(VELOCITY_Y); -NODES[10721].Fix(VELOCITY_Z); -NODES[10731].Fix(VELOCITY_X); -NODES[10731].Fix(VELOCITY_Y); -NODES[10731].Fix(VELOCITY_Z); -NODES[10732].Fix(VELOCITY_X); -NODES[10732].Fix(VELOCITY_Y); -NODES[10732].Fix(VELOCITY_Z); -NODES[10733].Fix(VELOCITY_X); -NODES[10733].Fix(VELOCITY_Y); -NODES[10733].Fix(VELOCITY_Z); -NODES[10734].Fix(VELOCITY_X); -NODES[10734].Fix(VELOCITY_Y); -NODES[10734].Fix(VELOCITY_Z); -NODES[10735].Fix(VELOCITY_X); -NODES[10735].Fix(VELOCITY_Y); -NODES[10735].Fix(VELOCITY_Z); -NODES[10736].Fix(VELOCITY_X); -NODES[10736].Fix(VELOCITY_Y); -NODES[10736].Fix(VELOCITY_Z); -NODES[10748].Fix(VELOCITY_X); -NODES[10748].Fix(VELOCITY_Y); -NODES[10748].Fix(VELOCITY_Z); -NODES[10751].Fix(VELOCITY_X); -NODES[10751].Fix(VELOCITY_Y); -NODES[10751].Fix(VELOCITY_Z); -NODES[10758].Fix(VELOCITY_X); -NODES[10758].Fix(VELOCITY_Y); -NODES[10758].Fix(VELOCITY_Z); -NODES[10759].Fix(VELOCITY_X); -NODES[10759].Fix(VELOCITY_Y); -NODES[10759].Fix(VELOCITY_Z); -NODES[10762].Fix(VELOCITY_X); -NODES[10762].Fix(VELOCITY_Y); -NODES[10762].Fix(VELOCITY_Z); -NODES[10763].Fix(VELOCITY_X); -NODES[10763].Fix(VELOCITY_Y); -NODES[10763].Fix(VELOCITY_Z); -NODES[10787].Fix(VELOCITY_X); -NODES[10787].Fix(VELOCITY_Y); -NODES[10787].Fix(VELOCITY_Z); -NODES[10792].Fix(VELOCITY_X); -NODES[10792].Fix(VELOCITY_Y); -NODES[10792].Fix(VELOCITY_Z); -NODES[10793].Fix(VELOCITY_X); -NODES[10793].Fix(VELOCITY_Y); -NODES[10793].Fix(VELOCITY_Z); -NODES[10798].Fix(VELOCITY_X); -NODES[10798].Fix(VELOCITY_Y); -NODES[10798].Fix(VELOCITY_Z); -NODES[10799].Fix(VELOCITY_X); -NODES[10799].Fix(VELOCITY_Y); -NODES[10799].Fix(VELOCITY_Z); -NODES[10802].Fix(VELOCITY_X); -NODES[10802].Fix(VELOCITY_Y); -NODES[10802].Fix(VELOCITY_Z); -NODES[10804].Fix(VELOCITY_X); -NODES[10804].Fix(VELOCITY_Y); -NODES[10804].Fix(VELOCITY_Z); -NODES[10808].Fix(VELOCITY_X); -NODES[10808].Fix(VELOCITY_Y); -NODES[10808].Fix(VELOCITY_Z); -NODES[10816].Fix(VELOCITY_X); -NODES[10816].Fix(VELOCITY_Y); -NODES[10816].Fix(VELOCITY_Z); -NODES[10827].Fix(VELOCITY_X); -NODES[10827].Fix(VELOCITY_Y); -NODES[10827].Fix(VELOCITY_Z); -NODES[10828].Fix(VELOCITY_X); -NODES[10828].Fix(VELOCITY_Y); -NODES[10828].Fix(VELOCITY_Z); -NODES[10832].Fix(VELOCITY_X); -NODES[10832].Fix(VELOCITY_Y); -NODES[10832].Fix(VELOCITY_Z); -NODES[10836].Fix(VELOCITY_X); -NODES[10836].Fix(VELOCITY_Y); -NODES[10836].Fix(VELOCITY_Z); -NODES[10842].Fix(VELOCITY_X); -NODES[10842].Fix(VELOCITY_Y); -NODES[10842].Fix(VELOCITY_Z); -NODES[10843].Fix(VELOCITY_X); -NODES[10843].Fix(VELOCITY_Y); -NODES[10843].Fix(VELOCITY_Z); -NODES[10863].Fix(VELOCITY_X); -NODES[10863].Fix(VELOCITY_Y); -NODES[10863].Fix(VELOCITY_Z); -NODES[10871].Fix(VELOCITY_X); -NODES[10871].Fix(VELOCITY_Y); -NODES[10871].Fix(VELOCITY_Z); -NODES[10877].Fix(VELOCITY_X); -NODES[10877].Fix(VELOCITY_Y); -NODES[10877].Fix(VELOCITY_Z); -NODES[10878].Fix(VELOCITY_X); -NODES[10878].Fix(VELOCITY_Y); -NODES[10878].Fix(VELOCITY_Z); -NODES[10879].Fix(VELOCITY_X); -NODES[10879].Fix(VELOCITY_Y); -NODES[10879].Fix(VELOCITY_Z); -NODES[10884].Fix(VELOCITY_X); -NODES[10884].Fix(VELOCITY_Y); -NODES[10884].Fix(VELOCITY_Z); -NODES[10885].Fix(VELOCITY_X); -NODES[10885].Fix(VELOCITY_Y); -NODES[10885].Fix(VELOCITY_Z); -NODES[10892].Fix(VELOCITY_X); -NODES[10892].Fix(VELOCITY_Y); -NODES[10892].Fix(VELOCITY_Z); -NODES[10913].Fix(VELOCITY_X); -NODES[10913].Fix(VELOCITY_Y); -NODES[10913].Fix(VELOCITY_Z); -NODES[10917].Fix(VELOCITY_X); -NODES[10917].Fix(VELOCITY_Y); -NODES[10917].Fix(VELOCITY_Z); -NODES[10929].Fix(VELOCITY_X); -NODES[10929].Fix(VELOCITY_Y); -NODES[10929].Fix(VELOCITY_Z); -NODES[10934].Fix(VELOCITY_X); -NODES[10934].Fix(VELOCITY_Y); -NODES[10934].Fix(VELOCITY_Z); -NODES[10935].Fix(VELOCITY_X); -NODES[10935].Fix(VELOCITY_Y); -NODES[10935].Fix(VELOCITY_Z); -NODES[10936].Fix(VELOCITY_X); -NODES[10936].Fix(VELOCITY_Y); -NODES[10936].Fix(VELOCITY_Z); -NODES[10938].Fix(VELOCITY_X); -NODES[10938].Fix(VELOCITY_Y); -NODES[10938].Fix(VELOCITY_Z); -NODES[10944].Fix(VELOCITY_X); -NODES[10944].Fix(VELOCITY_Y); -NODES[10944].Fix(VELOCITY_Z); -NODES[10947].Fix(VELOCITY_X); -NODES[10947].Fix(VELOCITY_Y); -NODES[10947].Fix(VELOCITY_Z); -NODES[10950].Fix(VELOCITY_X); -NODES[10950].Fix(VELOCITY_Y); -NODES[10950].Fix(VELOCITY_Z); -NODES[10952].Fix(VELOCITY_X); -NODES[10952].Fix(VELOCITY_Y); -NODES[10952].Fix(VELOCITY_Z); -NODES[10963].Fix(VELOCITY_X); -NODES[10963].Fix(VELOCITY_Y); -NODES[10963].Fix(VELOCITY_Z); -NODES[10971].Fix(VELOCITY_X); -NODES[10971].Fix(VELOCITY_Y); -NODES[10971].Fix(VELOCITY_Z); -NODES[10972].Fix(VELOCITY_X); -NODES[10972].Fix(VELOCITY_Y); -NODES[10972].Fix(VELOCITY_Z); -NODES[10979].Fix(VELOCITY_X); -NODES[10979].Fix(VELOCITY_Y); -NODES[10979].Fix(VELOCITY_Z); -NODES[10980].Fix(VELOCITY_X); -NODES[10980].Fix(VELOCITY_Y); -NODES[10980].Fix(VELOCITY_Z); -NODES[10991].Fix(VELOCITY_X); -NODES[10991].Fix(VELOCITY_Y); -NODES[10991].Fix(VELOCITY_Z); -NODES[10992].Fix(VELOCITY_X); -NODES[10992].Fix(VELOCITY_Y); -NODES[10992].Fix(VELOCITY_Z); -NODES[10995].Fix(VELOCITY_X); -NODES[10995].Fix(VELOCITY_Y); -NODES[10995].Fix(VELOCITY_Z); -NODES[10996].Fix(VELOCITY_X); -NODES[10996].Fix(VELOCITY_Y); -NODES[10996].Fix(VELOCITY_Z); -NODES[10997].Fix(VELOCITY_X); -NODES[10997].Fix(VELOCITY_Y); -NODES[10997].Fix(VELOCITY_Z); -NODES[11015].Fix(VELOCITY_X); -NODES[11015].Fix(VELOCITY_Y); -NODES[11015].Fix(VELOCITY_Z); -NODES[11017].Fix(VELOCITY_X); -NODES[11017].Fix(VELOCITY_Y); -NODES[11017].Fix(VELOCITY_Z); -NODES[11036].Fix(VELOCITY_X); -NODES[11036].Fix(VELOCITY_Y); -NODES[11036].Fix(VELOCITY_Z); -NODES[11047].Fix(VELOCITY_X); -NODES[11047].Fix(VELOCITY_Y); -NODES[11047].Fix(VELOCITY_Z); -NODES[11065].Fix(VELOCITY_X); -NODES[11065].Fix(VELOCITY_Y); -NODES[11065].Fix(VELOCITY_Z); -NODES[11075].Fix(VELOCITY_X); -NODES[11075].Fix(VELOCITY_Y); -NODES[11075].Fix(VELOCITY_Z); -NODES[11078].Fix(VELOCITY_X); -NODES[11078].Fix(VELOCITY_Y); -NODES[11078].Fix(VELOCITY_Z); -NODES[11090].Fix(VELOCITY_X); -NODES[11090].Fix(VELOCITY_Y); -NODES[11090].Fix(VELOCITY_Z); -NODES[11092].Fix(VELOCITY_X); -NODES[11092].Fix(VELOCITY_Y); -NODES[11092].Fix(VELOCITY_Z); -NODES[11093].Fix(VELOCITY_X); -NODES[11093].Fix(VELOCITY_Y); -NODES[11093].Fix(VELOCITY_Z); -NODES[11100].Fix(VELOCITY_X); -NODES[11100].Fix(VELOCITY_Y); -NODES[11100].Fix(VELOCITY_Z); -NODES[11101].Fix(VELOCITY_X); -NODES[11101].Fix(VELOCITY_Y); -NODES[11101].Fix(VELOCITY_Z); -NODES[11106].Fix(VELOCITY_X); -NODES[11106].Fix(VELOCITY_Y); -NODES[11106].Fix(VELOCITY_Z); -NODES[11107].Fix(VELOCITY_X); -NODES[11107].Fix(VELOCITY_Y); -NODES[11107].Fix(VELOCITY_Z); -NODES[11112].Fix(VELOCITY_X); -NODES[11112].Fix(VELOCITY_Y); -NODES[11112].Fix(VELOCITY_Z); -NODES[11113].Fix(VELOCITY_X); -NODES[11113].Fix(VELOCITY_Y); -NODES[11113].Fix(VELOCITY_Z); -NODES[11125].Fix(VELOCITY_X); -NODES[11125].Fix(VELOCITY_Y); -NODES[11125].Fix(VELOCITY_Z); -NODES[11126].Fix(VELOCITY_X); -NODES[11126].Fix(VELOCITY_Y); -NODES[11126].Fix(VELOCITY_Z); -NODES[11127].Fix(VELOCITY_X); -NODES[11127].Fix(VELOCITY_Y); -NODES[11127].Fix(VELOCITY_Z); -NODES[11137].Fix(VELOCITY_X); -NODES[11137].Fix(VELOCITY_Y); -NODES[11137].Fix(VELOCITY_Z); -NODES[11139].Fix(VELOCITY_X); -NODES[11139].Fix(VELOCITY_Y); -NODES[11139].Fix(VELOCITY_Z); -NODES[11140].Fix(VELOCITY_X); -NODES[11140].Fix(VELOCITY_Y); -NODES[11140].Fix(VELOCITY_Z); -NODES[11141].Fix(VELOCITY_X); -NODES[11141].Fix(VELOCITY_Y); -NODES[11141].Fix(VELOCITY_Z); -NODES[11142].Fix(VELOCITY_X); -NODES[11142].Fix(VELOCITY_Y); -NODES[11142].Fix(VELOCITY_Z); -NODES[11143].Fix(VELOCITY_X); -NODES[11143].Fix(VELOCITY_Y); -NODES[11143].Fix(VELOCITY_Z); -NODES[11151].Fix(VELOCITY_X); -NODES[11151].Fix(VELOCITY_Y); -NODES[11151].Fix(VELOCITY_Z); -NODES[11154].Fix(VELOCITY_X); -NODES[11154].Fix(VELOCITY_Y); -NODES[11154].Fix(VELOCITY_Z); -NODES[11155].Fix(VELOCITY_X); -NODES[11155].Fix(VELOCITY_Y); -NODES[11155].Fix(VELOCITY_Z); -NODES[11156].Fix(VELOCITY_X); -NODES[11156].Fix(VELOCITY_Y); -NODES[11156].Fix(VELOCITY_Z); -NODES[11157].Fix(VELOCITY_X); -NODES[11157].Fix(VELOCITY_Y); -NODES[11157].Fix(VELOCITY_Z); -NODES[11165].Fix(VELOCITY_X); -NODES[11165].Fix(VELOCITY_Y); -NODES[11165].Fix(VELOCITY_Z); -NODES[11176].Fix(VELOCITY_X); -NODES[11176].Fix(VELOCITY_Y); -NODES[11176].Fix(VELOCITY_Z); -NODES[11179].Fix(VELOCITY_X); -NODES[11179].Fix(VELOCITY_Y); -NODES[11179].Fix(VELOCITY_Z); -NODES[11180].Fix(VELOCITY_X); -NODES[11180].Fix(VELOCITY_Y); -NODES[11180].Fix(VELOCITY_Z); -NODES[11192].Fix(VELOCITY_X); -NODES[11192].Fix(VELOCITY_Y); -NODES[11192].Fix(VELOCITY_Z); -NODES[11193].Fix(VELOCITY_X); -NODES[11193].Fix(VELOCITY_Y); -NODES[11193].Fix(VELOCITY_Z); -NODES[11194].Fix(VELOCITY_X); -NODES[11194].Fix(VELOCITY_Y); -NODES[11194].Fix(VELOCITY_Z); -NODES[11195].Fix(VELOCITY_X); -NODES[11195].Fix(VELOCITY_Y); -NODES[11195].Fix(VELOCITY_Z); -NODES[11202].Fix(VELOCITY_X); -NODES[11202].Fix(VELOCITY_Y); -NODES[11202].Fix(VELOCITY_Z); -NODES[11213].Fix(VELOCITY_X); -NODES[11213].Fix(VELOCITY_Y); -NODES[11213].Fix(VELOCITY_Z); -NODES[11227].Fix(VELOCITY_X); -NODES[11227].Fix(VELOCITY_Y); -NODES[11227].Fix(VELOCITY_Z); -NODES[11247].Fix(VELOCITY_X); -NODES[11247].Fix(VELOCITY_Y); -NODES[11247].Fix(VELOCITY_Z); -NODES[11250].Fix(VELOCITY_X); -NODES[11250].Fix(VELOCITY_Y); -NODES[11250].Fix(VELOCITY_Z); -NODES[11251].Fix(VELOCITY_X); -NODES[11251].Fix(VELOCITY_Y); -NODES[11251].Fix(VELOCITY_Z); -NODES[11252].Fix(VELOCITY_X); -NODES[11252].Fix(VELOCITY_Y); -NODES[11252].Fix(VELOCITY_Z); -NODES[11262].Fix(VELOCITY_X); -NODES[11262].Fix(VELOCITY_Y); -NODES[11262].Fix(VELOCITY_Z); -NODES[11263].Fix(VELOCITY_X); -NODES[11263].Fix(VELOCITY_Y); -NODES[11263].Fix(VELOCITY_Z); -NODES[11264].Fix(VELOCITY_X); -NODES[11264].Fix(VELOCITY_Y); -NODES[11264].Fix(VELOCITY_Z); -NODES[11265].Fix(VELOCITY_X); -NODES[11265].Fix(VELOCITY_Y); -NODES[11265].Fix(VELOCITY_Z); -NODES[11266].Fix(VELOCITY_X); -NODES[11266].Fix(VELOCITY_Y); -NODES[11266].Fix(VELOCITY_Z); -NODES[11270].Fix(VELOCITY_X); -NODES[11270].Fix(VELOCITY_Y); -NODES[11270].Fix(VELOCITY_Z); -NODES[11302].Fix(VELOCITY_X); -NODES[11302].Fix(VELOCITY_Y); -NODES[11302].Fix(VELOCITY_Z); -NODES[11309].Fix(VELOCITY_X); -NODES[11309].Fix(VELOCITY_Y); -NODES[11309].Fix(VELOCITY_Z); -NODES[11319].Fix(VELOCITY_X); -NODES[11319].Fix(VELOCITY_Y); -NODES[11319].Fix(VELOCITY_Z); -NODES[11329].Fix(VELOCITY_X); -NODES[11329].Fix(VELOCITY_Y); -NODES[11329].Fix(VELOCITY_Z); -NODES[11334].Fix(VELOCITY_X); -NODES[11334].Fix(VELOCITY_Y); -NODES[11334].Fix(VELOCITY_Z); -NODES[11337].Fix(VELOCITY_X); -NODES[11337].Fix(VELOCITY_Y); -NODES[11337].Fix(VELOCITY_Z); -NODES[11338].Fix(VELOCITY_X); -NODES[11338].Fix(VELOCITY_Y); -NODES[11338].Fix(VELOCITY_Z); -NODES[11340].Fix(VELOCITY_X); -NODES[11340].Fix(VELOCITY_Y); -NODES[11340].Fix(VELOCITY_Z); -NODES[11343].Fix(VELOCITY_X); -NODES[11343].Fix(VELOCITY_Y); -NODES[11343].Fix(VELOCITY_Z); -NODES[11353].Fix(VELOCITY_X); -NODES[11353].Fix(VELOCITY_Y); -NODES[11353].Fix(VELOCITY_Z); -NODES[11354].Fix(VELOCITY_X); -NODES[11354].Fix(VELOCITY_Y); -NODES[11354].Fix(VELOCITY_Z); -NODES[11355].Fix(VELOCITY_X); -NODES[11355].Fix(VELOCITY_Y); -NODES[11355].Fix(VELOCITY_Z); -NODES[11356].Fix(VELOCITY_X); -NODES[11356].Fix(VELOCITY_Y); -NODES[11356].Fix(VELOCITY_Z); -NODES[11357].Fix(VELOCITY_X); -NODES[11357].Fix(VELOCITY_Y); -NODES[11357].Fix(VELOCITY_Z); -NODES[11361].Fix(VELOCITY_X); -NODES[11361].Fix(VELOCITY_Y); -NODES[11361].Fix(VELOCITY_Z); -NODES[11368].Fix(VELOCITY_X); -NODES[11368].Fix(VELOCITY_Y); -NODES[11368].Fix(VELOCITY_Z); -NODES[11370].Fix(VELOCITY_X); -NODES[11370].Fix(VELOCITY_Y); -NODES[11370].Fix(VELOCITY_Z); -NODES[11372].Fix(VELOCITY_X); -NODES[11372].Fix(VELOCITY_Y); -NODES[11372].Fix(VELOCITY_Z); -NODES[11384].Fix(VELOCITY_X); -NODES[11384].Fix(VELOCITY_Y); -NODES[11384].Fix(VELOCITY_Z); -NODES[11408].Fix(VELOCITY_X); -NODES[11408].Fix(VELOCITY_Y); -NODES[11408].Fix(VELOCITY_Z); -NODES[11414].Fix(VELOCITY_X); -NODES[11414].Fix(VELOCITY_Y); -NODES[11414].Fix(VELOCITY_Z); -NODES[11426].Fix(VELOCITY_X); -NODES[11426].Fix(VELOCITY_Y); -NODES[11426].Fix(VELOCITY_Z); -NODES[11427].Fix(VELOCITY_X); -NODES[11427].Fix(VELOCITY_Y); -NODES[11427].Fix(VELOCITY_Z); -NODES[11431].Fix(VELOCITY_X); -NODES[11431].Fix(VELOCITY_Y); -NODES[11431].Fix(VELOCITY_Z); -NODES[11437].Fix(VELOCITY_X); -NODES[11437].Fix(VELOCITY_Y); -NODES[11437].Fix(VELOCITY_Z); -NODES[11464].Fix(VELOCITY_X); -NODES[11464].Fix(VELOCITY_Y); -NODES[11464].Fix(VELOCITY_Z); -NODES[11465].Fix(VELOCITY_X); -NODES[11465].Fix(VELOCITY_Y); -NODES[11465].Fix(VELOCITY_Z); -NODES[11466].Fix(VELOCITY_X); -NODES[11466].Fix(VELOCITY_Y); -NODES[11466].Fix(VELOCITY_Z); -NODES[11467].Fix(VELOCITY_X); -NODES[11467].Fix(VELOCITY_Y); -NODES[11467].Fix(VELOCITY_Z); -NODES[11468].Fix(VELOCITY_X); -NODES[11468].Fix(VELOCITY_Y); -NODES[11468].Fix(VELOCITY_Z); -NODES[11469].Fix(VELOCITY_X); -NODES[11469].Fix(VELOCITY_Y); -NODES[11469].Fix(VELOCITY_Z); -NODES[11471].Fix(VELOCITY_X); -NODES[11471].Fix(VELOCITY_Y); -NODES[11471].Fix(VELOCITY_Z); -NODES[11472].Fix(VELOCITY_X); -NODES[11472].Fix(VELOCITY_Y); -NODES[11472].Fix(VELOCITY_Z); -NODES[11476].Fix(VELOCITY_X); -NODES[11476].Fix(VELOCITY_Y); -NODES[11476].Fix(VELOCITY_Z); -NODES[11486].Fix(VELOCITY_X); -NODES[11486].Fix(VELOCITY_Y); -NODES[11486].Fix(VELOCITY_Z); -NODES[11487].Fix(VELOCITY_X); -NODES[11487].Fix(VELOCITY_Y); -NODES[11487].Fix(VELOCITY_Z); -NODES[11491].Fix(VELOCITY_X); -NODES[11491].Fix(VELOCITY_Y); -NODES[11491].Fix(VELOCITY_Z); -NODES[11493].Fix(VELOCITY_X); -NODES[11493].Fix(VELOCITY_Y); -NODES[11493].Fix(VELOCITY_Z); -NODES[11494].Fix(VELOCITY_X); -NODES[11494].Fix(VELOCITY_Y); -NODES[11494].Fix(VELOCITY_Z); -NODES[11502].Fix(VELOCITY_X); -NODES[11502].Fix(VELOCITY_Y); -NODES[11502].Fix(VELOCITY_Z); -NODES[11507].Fix(VELOCITY_X); -NODES[11507].Fix(VELOCITY_Y); -NODES[11507].Fix(VELOCITY_Z); -NODES[11510].Fix(VELOCITY_X); -NODES[11510].Fix(VELOCITY_Y); -NODES[11510].Fix(VELOCITY_Z); -NODES[11513].Fix(VELOCITY_X); -NODES[11513].Fix(VELOCITY_Y); -NODES[11513].Fix(VELOCITY_Z); -NODES[11527].Fix(VELOCITY_X); -NODES[11527].Fix(VELOCITY_Y); -NODES[11527].Fix(VELOCITY_Z); -NODES[11528].Fix(VELOCITY_X); -NODES[11528].Fix(VELOCITY_Y); -NODES[11528].Fix(VELOCITY_Z); -NODES[11531].Fix(VELOCITY_X); -NODES[11531].Fix(VELOCITY_Y); -NODES[11531].Fix(VELOCITY_Z); -NODES[11550].Fix(VELOCITY_X); -NODES[11550].Fix(VELOCITY_Y); -NODES[11550].Fix(VELOCITY_Z); -NODES[11563].Fix(VELOCITY_X); -NODES[11563].Fix(VELOCITY_Y); -NODES[11563].Fix(VELOCITY_Z); -NODES[11564].Fix(VELOCITY_X); -NODES[11564].Fix(VELOCITY_Y); -NODES[11564].Fix(VELOCITY_Z); -NODES[11569].Fix(VELOCITY_X); -NODES[11569].Fix(VELOCITY_Y); -NODES[11569].Fix(VELOCITY_Z); -NODES[11574].Fix(VELOCITY_X); -NODES[11574].Fix(VELOCITY_Y); -NODES[11574].Fix(VELOCITY_Z); -NODES[11584].Fix(VELOCITY_X); -NODES[11584].Fix(VELOCITY_Y); -NODES[11584].Fix(VELOCITY_Z); -NODES[11585].Fix(VELOCITY_X); -NODES[11585].Fix(VELOCITY_Y); -NODES[11585].Fix(VELOCITY_Z); -NODES[11586].Fix(VELOCITY_X); -NODES[11586].Fix(VELOCITY_Y); -NODES[11586].Fix(VELOCITY_Z); -NODES[11596].Fix(VELOCITY_X); -NODES[11596].Fix(VELOCITY_Y); -NODES[11596].Fix(VELOCITY_Z); -NODES[11597].Fix(VELOCITY_X); -NODES[11597].Fix(VELOCITY_Y); -NODES[11597].Fix(VELOCITY_Z); -NODES[11598].Fix(VELOCITY_X); -NODES[11598].Fix(VELOCITY_Y); -NODES[11598].Fix(VELOCITY_Z); -NODES[11599].Fix(VELOCITY_X); -NODES[11599].Fix(VELOCITY_Y); -NODES[11599].Fix(VELOCITY_Z); -NODES[11600].Fix(VELOCITY_X); -NODES[11600].Fix(VELOCITY_Y); -NODES[11600].Fix(VELOCITY_Z); -NODES[11606].Fix(VELOCITY_X); -NODES[11606].Fix(VELOCITY_Y); -NODES[11606].Fix(VELOCITY_Z); -NODES[11624].Fix(VELOCITY_X); -NODES[11624].Fix(VELOCITY_Y); -NODES[11624].Fix(VELOCITY_Z); -NODES[11625].Fix(VELOCITY_X); -NODES[11625].Fix(VELOCITY_Y); -NODES[11625].Fix(VELOCITY_Z); -NODES[11626].Fix(VELOCITY_X); -NODES[11626].Fix(VELOCITY_Y); -NODES[11626].Fix(VELOCITY_Z); -NODES[11627].Fix(VELOCITY_X); -NODES[11627].Fix(VELOCITY_Y); -NODES[11627].Fix(VELOCITY_Z); -NODES[11633].Fix(VELOCITY_X); -NODES[11633].Fix(VELOCITY_Y); -NODES[11633].Fix(VELOCITY_Z); -NODES[11642].Fix(VELOCITY_X); -NODES[11642].Fix(VELOCITY_Y); -NODES[11642].Fix(VELOCITY_Z); -NODES[11644].Fix(VELOCITY_X); -NODES[11644].Fix(VELOCITY_Y); -NODES[11644].Fix(VELOCITY_Z); -NODES[11651].Fix(VELOCITY_X); -NODES[11651].Fix(VELOCITY_Y); -NODES[11651].Fix(VELOCITY_Z); -NODES[11655].Fix(VELOCITY_X); -NODES[11655].Fix(VELOCITY_Y); -NODES[11655].Fix(VELOCITY_Z); -NODES[11659].Fix(VELOCITY_X); -NODES[11659].Fix(VELOCITY_Y); -NODES[11659].Fix(VELOCITY_Z); -NODES[11660].Fix(VELOCITY_X); -NODES[11660].Fix(VELOCITY_Y); -NODES[11660].Fix(VELOCITY_Z); -NODES[11661].Fix(VELOCITY_X); -NODES[11661].Fix(VELOCITY_Y); -NODES[11661].Fix(VELOCITY_Z); -NODES[11662].Fix(VELOCITY_X); -NODES[11662].Fix(VELOCITY_Y); -NODES[11662].Fix(VELOCITY_Z); -NODES[11667].Fix(VELOCITY_X); -NODES[11667].Fix(VELOCITY_Y); -NODES[11667].Fix(VELOCITY_Z); -NODES[11677].Fix(VELOCITY_X); -NODES[11677].Fix(VELOCITY_Y); -NODES[11677].Fix(VELOCITY_Z); -NODES[11678].Fix(VELOCITY_X); -NODES[11678].Fix(VELOCITY_Y); -NODES[11678].Fix(VELOCITY_Z); -NODES[11679].Fix(VELOCITY_X); -NODES[11679].Fix(VELOCITY_Y); -NODES[11679].Fix(VELOCITY_Z); -NODES[11684].Fix(VELOCITY_X); -NODES[11684].Fix(VELOCITY_Y); -NODES[11684].Fix(VELOCITY_Z); -NODES[11685].Fix(VELOCITY_X); -NODES[11685].Fix(VELOCITY_Y); -NODES[11685].Fix(VELOCITY_Z); -NODES[11695].Fix(VELOCITY_X); -NODES[11695].Fix(VELOCITY_Y); -NODES[11695].Fix(VELOCITY_Z); -NODES[11700].Fix(VELOCITY_X); -NODES[11700].Fix(VELOCITY_Y); -NODES[11700].Fix(VELOCITY_Z); -NODES[11711].Fix(VELOCITY_X); -NODES[11711].Fix(VELOCITY_Y); -NODES[11711].Fix(VELOCITY_Z); -NODES[11720].Fix(VELOCITY_X); -NODES[11720].Fix(VELOCITY_Y); -NODES[11720].Fix(VELOCITY_Z); -NODES[11734].Fix(VELOCITY_X); -NODES[11734].Fix(VELOCITY_Y); -NODES[11734].Fix(VELOCITY_Z); -NODES[11736].Fix(VELOCITY_X); -NODES[11736].Fix(VELOCITY_Y); -NODES[11736].Fix(VELOCITY_Z); -NODES[11738].Fix(VELOCITY_X); -NODES[11738].Fix(VELOCITY_Y); -NODES[11738].Fix(VELOCITY_Z); -NODES[11740].Fix(VELOCITY_X); -NODES[11740].Fix(VELOCITY_Y); -NODES[11740].Fix(VELOCITY_Z); -NODES[11751].Fix(VELOCITY_X); -NODES[11751].Fix(VELOCITY_Y); -NODES[11751].Fix(VELOCITY_Z); -NODES[11752].Fix(VELOCITY_X); -NODES[11752].Fix(VELOCITY_Y); -NODES[11752].Fix(VELOCITY_Z); -NODES[11753].Fix(VELOCITY_X); -NODES[11753].Fix(VELOCITY_Y); -NODES[11753].Fix(VELOCITY_Z); -NODES[11754].Fix(VELOCITY_X); -NODES[11754].Fix(VELOCITY_Y); -NODES[11754].Fix(VELOCITY_Z); -NODES[11761].Fix(VELOCITY_X); -NODES[11761].Fix(VELOCITY_Y); -NODES[11761].Fix(VELOCITY_Z); -NODES[11792].Fix(VELOCITY_X); -NODES[11792].Fix(VELOCITY_Y); -NODES[11792].Fix(VELOCITY_Z); -NODES[11793].Fix(VELOCITY_X); -NODES[11793].Fix(VELOCITY_Y); -NODES[11793].Fix(VELOCITY_Z); -NODES[11803].Fix(VELOCITY_X); -NODES[11803].Fix(VELOCITY_Y); -NODES[11803].Fix(VELOCITY_Z); -NODES[11806].Fix(VELOCITY_X); -NODES[11806].Fix(VELOCITY_Y); -NODES[11806].Fix(VELOCITY_Z); -NODES[11817].Fix(VELOCITY_X); -NODES[11817].Fix(VELOCITY_Y); -NODES[11817].Fix(VELOCITY_Z); -NODES[11822].Fix(VELOCITY_X); -NODES[11822].Fix(VELOCITY_Y); -NODES[11822].Fix(VELOCITY_Z); -NODES[11826].Fix(VELOCITY_X); -NODES[11826].Fix(VELOCITY_Y); -NODES[11826].Fix(VELOCITY_Z); -NODES[11827].Fix(VELOCITY_X); -NODES[11827].Fix(VELOCITY_Y); -NODES[11827].Fix(VELOCITY_Z); -NODES[11828].Fix(VELOCITY_X); -NODES[11828].Fix(VELOCITY_Y); -NODES[11828].Fix(VELOCITY_Z); -NODES[11831].Fix(VELOCITY_X); -NODES[11831].Fix(VELOCITY_Y); -NODES[11831].Fix(VELOCITY_Z); -NODES[11836].Fix(VELOCITY_X); -NODES[11836].Fix(VELOCITY_Y); -NODES[11836].Fix(VELOCITY_Z); -NODES[11845].Fix(VELOCITY_X); -NODES[11845].Fix(VELOCITY_Y); -NODES[11845].Fix(VELOCITY_Z); -NODES[11846].Fix(VELOCITY_X); -NODES[11846].Fix(VELOCITY_Y); -NODES[11846].Fix(VELOCITY_Z); -NODES[11865].Fix(VELOCITY_X); -NODES[11865].Fix(VELOCITY_Y); -NODES[11865].Fix(VELOCITY_Z); -NODES[11867].Fix(VELOCITY_X); -NODES[11867].Fix(VELOCITY_Y); -NODES[11867].Fix(VELOCITY_Z); -NODES[11873].Fix(VELOCITY_X); -NODES[11873].Fix(VELOCITY_Y); -NODES[11873].Fix(VELOCITY_Z); -NODES[11877].Fix(VELOCITY_X); -NODES[11877].Fix(VELOCITY_Y); -NODES[11877].Fix(VELOCITY_Z); -NODES[11910].Fix(VELOCITY_X); -NODES[11910].Fix(VELOCITY_Y); -NODES[11910].Fix(VELOCITY_Z); -NODES[11915].Fix(VELOCITY_X); -NODES[11915].Fix(VELOCITY_Y); -NODES[11915].Fix(VELOCITY_Z); -NODES[11916].Fix(VELOCITY_X); -NODES[11916].Fix(VELOCITY_Y); -NODES[11916].Fix(VELOCITY_Z); -NODES[11919].Fix(VELOCITY_X); -NODES[11919].Fix(VELOCITY_Y); -NODES[11919].Fix(VELOCITY_Z); -NODES[11937].Fix(VELOCITY_X); -NODES[11937].Fix(VELOCITY_Y); -NODES[11937].Fix(VELOCITY_Z); -NODES[11938].Fix(VELOCITY_X); -NODES[11938].Fix(VELOCITY_Y); -NODES[11938].Fix(VELOCITY_Z); -NODES[11939].Fix(VELOCITY_X); -NODES[11939].Fix(VELOCITY_Y); -NODES[11939].Fix(VELOCITY_Z); -NODES[11940].Fix(VELOCITY_X); -NODES[11940].Fix(VELOCITY_Y); -NODES[11940].Fix(VELOCITY_Z); -NODES[11953].Fix(VELOCITY_X); -NODES[11953].Fix(VELOCITY_Y); -NODES[11953].Fix(VELOCITY_Z); -NODES[11960].Fix(VELOCITY_X); -NODES[11960].Fix(VELOCITY_Y); -NODES[11960].Fix(VELOCITY_Z); -NODES[11961].Fix(VELOCITY_X); -NODES[11961].Fix(VELOCITY_Y); -NODES[11961].Fix(VELOCITY_Z); -NODES[11967].Fix(VELOCITY_X); -NODES[11967].Fix(VELOCITY_Y); -NODES[11967].Fix(VELOCITY_Z); -NODES[11971].Fix(VELOCITY_X); -NODES[11971].Fix(VELOCITY_Y); -NODES[11971].Fix(VELOCITY_Z); -NODES[11985].Fix(VELOCITY_X); -NODES[11985].Fix(VELOCITY_Y); -NODES[11985].Fix(VELOCITY_Z); -NODES[11991].Fix(VELOCITY_X); -NODES[11991].Fix(VELOCITY_Y); -NODES[11991].Fix(VELOCITY_Z); -NODES[12003].Fix(VELOCITY_X); -NODES[12003].Fix(VELOCITY_Y); -NODES[12003].Fix(VELOCITY_Z); -NODES[12006].Fix(VELOCITY_X); -NODES[12006].Fix(VELOCITY_Y); -NODES[12006].Fix(VELOCITY_Z); -NODES[12013].Fix(VELOCITY_X); -NODES[12013].Fix(VELOCITY_Y); -NODES[12013].Fix(VELOCITY_Z); -NODES[12028].Fix(VELOCITY_X); -NODES[12028].Fix(VELOCITY_Y); -NODES[12028].Fix(VELOCITY_Z); -NODES[12030].Fix(VELOCITY_X); -NODES[12030].Fix(VELOCITY_Y); -NODES[12030].Fix(VELOCITY_Z); -NODES[12033].Fix(VELOCITY_X); -NODES[12033].Fix(VELOCITY_Y); -NODES[12033].Fix(VELOCITY_Z); -NODES[12042].Fix(VELOCITY_X); -NODES[12042].Fix(VELOCITY_Y); -NODES[12042].Fix(VELOCITY_Z); -NODES[12052].Fix(VELOCITY_X); -NODES[12052].Fix(VELOCITY_Y); -NODES[12052].Fix(VELOCITY_Z); -NODES[12067].Fix(VELOCITY_X); -NODES[12067].Fix(VELOCITY_Y); -NODES[12067].Fix(VELOCITY_Z); -NODES[12070].Fix(VELOCITY_X); -NODES[12070].Fix(VELOCITY_Y); -NODES[12070].Fix(VELOCITY_Z); -NODES[12072].Fix(VELOCITY_X); -NODES[12072].Fix(VELOCITY_Y); -NODES[12072].Fix(VELOCITY_Z); -NODES[12081].Fix(VELOCITY_X); -NODES[12081].Fix(VELOCITY_Y); -NODES[12081].Fix(VELOCITY_Z); -NODES[12084].Fix(VELOCITY_X); -NODES[12084].Fix(VELOCITY_Y); -NODES[12084].Fix(VELOCITY_Z); -NODES[12086].Fix(VELOCITY_X); -NODES[12086].Fix(VELOCITY_Y); -NODES[12086].Fix(VELOCITY_Z); -NODES[12094].Fix(VELOCITY_X); -NODES[12094].Fix(VELOCITY_Y); -NODES[12094].Fix(VELOCITY_Z); -NODES[12095].Fix(VELOCITY_X); -NODES[12095].Fix(VELOCITY_Y); -NODES[12095].Fix(VELOCITY_Z); -NODES[12096].Fix(VELOCITY_X); -NODES[12096].Fix(VELOCITY_Y); -NODES[12096].Fix(VELOCITY_Z); -NODES[12115].Fix(VELOCITY_X); -NODES[12115].Fix(VELOCITY_Y); -NODES[12115].Fix(VELOCITY_Z); -NODES[12117].Fix(VELOCITY_X); -NODES[12117].Fix(VELOCITY_Y); -NODES[12117].Fix(VELOCITY_Z); -NODES[12134].Fix(VELOCITY_X); -NODES[12134].Fix(VELOCITY_Y); -NODES[12134].Fix(VELOCITY_Z); -NODES[12135].Fix(VELOCITY_X); -NODES[12135].Fix(VELOCITY_Y); -NODES[12135].Fix(VELOCITY_Z); -NODES[12136].Fix(VELOCITY_X); -NODES[12136].Fix(VELOCITY_Y); -NODES[12136].Fix(VELOCITY_Z); -NODES[12137].Fix(VELOCITY_X); -NODES[12137].Fix(VELOCITY_Y); -NODES[12137].Fix(VELOCITY_Z); -NODES[12138].Fix(VELOCITY_X); -NODES[12138].Fix(VELOCITY_Y); -NODES[12138].Fix(VELOCITY_Z); -NODES[12139].Fix(VELOCITY_X); -NODES[12139].Fix(VELOCITY_Y); -NODES[12139].Fix(VELOCITY_Z); -NODES[12143].Fix(VELOCITY_X); -NODES[12143].Fix(VELOCITY_Y); -NODES[12143].Fix(VELOCITY_Z); -NODES[12151].Fix(VELOCITY_X); -NODES[12151].Fix(VELOCITY_Y); -NODES[12151].Fix(VELOCITY_Z); -NODES[12169].Fix(VELOCITY_X); -NODES[12169].Fix(VELOCITY_Y); -NODES[12169].Fix(VELOCITY_Z); -NODES[12170].Fix(VELOCITY_X); -NODES[12170].Fix(VELOCITY_Y); -NODES[12170].Fix(VELOCITY_Z); -NODES[12171].Fix(VELOCITY_X); -NODES[12171].Fix(VELOCITY_Y); -NODES[12171].Fix(VELOCITY_Z); -NODES[12172].Fix(VELOCITY_X); -NODES[12172].Fix(VELOCITY_Y); -NODES[12172].Fix(VELOCITY_Z); -NODES[12183].Fix(VELOCITY_X); -NODES[12183].Fix(VELOCITY_Y); -NODES[12183].Fix(VELOCITY_Z); -NODES[12192].Fix(VELOCITY_X); -NODES[12192].Fix(VELOCITY_Y); -NODES[12192].Fix(VELOCITY_Z); -NODES[12197].Fix(VELOCITY_X); -NODES[12197].Fix(VELOCITY_Y); -NODES[12197].Fix(VELOCITY_Z); -NODES[12211].Fix(VELOCITY_X); -NODES[12211].Fix(VELOCITY_Y); -NODES[12211].Fix(VELOCITY_Z); -NODES[12221].Fix(VELOCITY_X); -NODES[12221].Fix(VELOCITY_Y); -NODES[12221].Fix(VELOCITY_Z); -NODES[12225].Fix(VELOCITY_X); -NODES[12225].Fix(VELOCITY_Y); -NODES[12225].Fix(VELOCITY_Z); -NODES[12230].Fix(VELOCITY_X); -NODES[12230].Fix(VELOCITY_Y); -NODES[12230].Fix(VELOCITY_Z); -NODES[12235].Fix(VELOCITY_X); -NODES[12235].Fix(VELOCITY_Y); -NODES[12235].Fix(VELOCITY_Z); -NODES[12265].Fix(VELOCITY_X); -NODES[12265].Fix(VELOCITY_Y); -NODES[12265].Fix(VELOCITY_Z); -NODES[12266].Fix(VELOCITY_X); -NODES[12266].Fix(VELOCITY_Y); -NODES[12266].Fix(VELOCITY_Z); -NODES[12270].Fix(VELOCITY_X); -NODES[12270].Fix(VELOCITY_Y); -NODES[12270].Fix(VELOCITY_Z); -NODES[12294].Fix(VELOCITY_X); -NODES[12294].Fix(VELOCITY_Y); -NODES[12294].Fix(VELOCITY_Z); -NODES[12309].Fix(VELOCITY_X); -NODES[12309].Fix(VELOCITY_Y); -NODES[12309].Fix(VELOCITY_Z); -NODES[12314].Fix(VELOCITY_X); -NODES[12314].Fix(VELOCITY_Y); -NODES[12314].Fix(VELOCITY_Z); -NODES[12315].Fix(VELOCITY_X); -NODES[12315].Fix(VELOCITY_Y); -NODES[12315].Fix(VELOCITY_Z); -NODES[12316].Fix(VELOCITY_X); -NODES[12316].Fix(VELOCITY_Y); -NODES[12316].Fix(VELOCITY_Z); -NODES[12318].Fix(VELOCITY_X); -NODES[12318].Fix(VELOCITY_Y); -NODES[12318].Fix(VELOCITY_Z); -NODES[12328].Fix(VELOCITY_X); -NODES[12328].Fix(VELOCITY_Y); -NODES[12328].Fix(VELOCITY_Z); -NODES[12329].Fix(VELOCITY_X); -NODES[12329].Fix(VELOCITY_Y); -NODES[12329].Fix(VELOCITY_Z); -NODES[12337].Fix(VELOCITY_X); -NODES[12337].Fix(VELOCITY_Y); -NODES[12337].Fix(VELOCITY_Z); -NODES[12338].Fix(VELOCITY_X); -NODES[12338].Fix(VELOCITY_Y); -NODES[12338].Fix(VELOCITY_Z); -NODES[12339].Fix(VELOCITY_X); -NODES[12339].Fix(VELOCITY_Y); -NODES[12339].Fix(VELOCITY_Z); -NODES[12340].Fix(VELOCITY_X); -NODES[12340].Fix(VELOCITY_Y); -NODES[12340].Fix(VELOCITY_Z); -NODES[12342].Fix(VELOCITY_X); -NODES[12342].Fix(VELOCITY_Y); -NODES[12342].Fix(VELOCITY_Z); -NODES[12349].Fix(VELOCITY_X); -NODES[12349].Fix(VELOCITY_Y); -NODES[12349].Fix(VELOCITY_Z); -NODES[12355].Fix(VELOCITY_X); -NODES[12355].Fix(VELOCITY_Y); -NODES[12355].Fix(VELOCITY_Z); -NODES[12360].Fix(VELOCITY_X); -NODES[12360].Fix(VELOCITY_Y); -NODES[12360].Fix(VELOCITY_Z); -NODES[12361].Fix(VELOCITY_X); -NODES[12361].Fix(VELOCITY_Y); -NODES[12361].Fix(VELOCITY_Z); -NODES[12362].Fix(VELOCITY_X); -NODES[12362].Fix(VELOCITY_Y); -NODES[12362].Fix(VELOCITY_Z); -NODES[12363].Fix(VELOCITY_X); -NODES[12363].Fix(VELOCITY_Y); -NODES[12363].Fix(VELOCITY_Z); -NODES[12371].Fix(VELOCITY_X); -NODES[12371].Fix(VELOCITY_Y); -NODES[12371].Fix(VELOCITY_Z); -NODES[12375].Fix(VELOCITY_X); -NODES[12375].Fix(VELOCITY_Y); -NODES[12375].Fix(VELOCITY_Z); -NODES[12395].Fix(VELOCITY_X); -NODES[12395].Fix(VELOCITY_Y); -NODES[12395].Fix(VELOCITY_Z); -NODES[12396].Fix(VELOCITY_X); -NODES[12396].Fix(VELOCITY_Y); -NODES[12396].Fix(VELOCITY_Z); -NODES[12397].Fix(VELOCITY_X); -NODES[12397].Fix(VELOCITY_Y); -NODES[12397].Fix(VELOCITY_Z); -NODES[12399].Fix(VELOCITY_X); -NODES[12399].Fix(VELOCITY_Y); -NODES[12399].Fix(VELOCITY_Z); -NODES[12400].Fix(VELOCITY_X); -NODES[12400].Fix(VELOCITY_Y); -NODES[12400].Fix(VELOCITY_Z); -NODES[12431].Fix(VELOCITY_X); -NODES[12431].Fix(VELOCITY_Y); -NODES[12431].Fix(VELOCITY_Z); -NODES[12434].Fix(VELOCITY_X); -NODES[12434].Fix(VELOCITY_Y); -NODES[12434].Fix(VELOCITY_Z); -NODES[12439].Fix(VELOCITY_X); -NODES[12439].Fix(VELOCITY_Y); -NODES[12439].Fix(VELOCITY_Z); -NODES[12446].Fix(VELOCITY_X); -NODES[12446].Fix(VELOCITY_Y); -NODES[12446].Fix(VELOCITY_Z); -NODES[12449].Fix(VELOCITY_X); -NODES[12449].Fix(VELOCITY_Y); -NODES[12449].Fix(VELOCITY_Z); -NODES[12451].Fix(VELOCITY_X); -NODES[12451].Fix(VELOCITY_Y); -NODES[12451].Fix(VELOCITY_Z); -NODES[12452].Fix(VELOCITY_X); -NODES[12452].Fix(VELOCITY_Y); -NODES[12452].Fix(VELOCITY_Z); -NODES[12453].Fix(VELOCITY_X); -NODES[12453].Fix(VELOCITY_Y); -NODES[12453].Fix(VELOCITY_Z); -NODES[12456].Fix(VELOCITY_X); -NODES[12456].Fix(VELOCITY_Y); -NODES[12456].Fix(VELOCITY_Z); -NODES[12458].Fix(VELOCITY_X); -NODES[12458].Fix(VELOCITY_Y); -NODES[12458].Fix(VELOCITY_Z); -NODES[12460].Fix(VELOCITY_X); -NODES[12460].Fix(VELOCITY_Y); -NODES[12460].Fix(VELOCITY_Z); -NODES[12461].Fix(VELOCITY_X); -NODES[12461].Fix(VELOCITY_Y); -NODES[12461].Fix(VELOCITY_Z); -NODES[12470].Fix(VELOCITY_X); -NODES[12470].Fix(VELOCITY_Y); -NODES[12470].Fix(VELOCITY_Z); -NODES[12471].Fix(VELOCITY_X); -NODES[12471].Fix(VELOCITY_Y); -NODES[12471].Fix(VELOCITY_Z); -NODES[12487].Fix(VELOCITY_X); -NODES[12487].Fix(VELOCITY_Y); -NODES[12487].Fix(VELOCITY_Z); -NODES[12488].Fix(VELOCITY_X); -NODES[12488].Fix(VELOCITY_Y); -NODES[12488].Fix(VELOCITY_Z); -NODES[12489].Fix(VELOCITY_X); -NODES[12489].Fix(VELOCITY_Y); -NODES[12489].Fix(VELOCITY_Z); -NODES[12498].Fix(VELOCITY_X); -NODES[12498].Fix(VELOCITY_Y); -NODES[12498].Fix(VELOCITY_Z); -NODES[12508].Fix(VELOCITY_X); -NODES[12508].Fix(VELOCITY_Y); -NODES[12508].Fix(VELOCITY_Z); -NODES[12509].Fix(VELOCITY_X); -NODES[12509].Fix(VELOCITY_Y); -NODES[12509].Fix(VELOCITY_Z); -NODES[12523].Fix(VELOCITY_X); -NODES[12523].Fix(VELOCITY_Y); -NODES[12523].Fix(VELOCITY_Z); -NODES[12529].Fix(VELOCITY_X); -NODES[12529].Fix(VELOCITY_Y); -NODES[12529].Fix(VELOCITY_Z); -NODES[12536].Fix(VELOCITY_X); -NODES[12536].Fix(VELOCITY_Y); -NODES[12536].Fix(VELOCITY_Z); -NODES[12548].Fix(VELOCITY_X); -NODES[12548].Fix(VELOCITY_Y); -NODES[12548].Fix(VELOCITY_Z); -NODES[12558].Fix(VELOCITY_X); -NODES[12558].Fix(VELOCITY_Y); -NODES[12558].Fix(VELOCITY_Z); -NODES[12559].Fix(VELOCITY_X); -NODES[12559].Fix(VELOCITY_Y); -NODES[12559].Fix(VELOCITY_Z); -NODES[12564].Fix(VELOCITY_X); -NODES[12564].Fix(VELOCITY_Y); -NODES[12564].Fix(VELOCITY_Z); -NODES[12567].Fix(VELOCITY_X); -NODES[12567].Fix(VELOCITY_Y); -NODES[12567].Fix(VELOCITY_Z); -NODES[12574].Fix(VELOCITY_X); -NODES[12574].Fix(VELOCITY_Y); -NODES[12574].Fix(VELOCITY_Z); -NODES[12596].Fix(VELOCITY_X); -NODES[12596].Fix(VELOCITY_Y); -NODES[12596].Fix(VELOCITY_Z); -NODES[12597].Fix(VELOCITY_X); -NODES[12597].Fix(VELOCITY_Y); -NODES[12597].Fix(VELOCITY_Z); -NODES[12598].Fix(VELOCITY_X); -NODES[12598].Fix(VELOCITY_Y); -NODES[12598].Fix(VELOCITY_Z); -NODES[12599].Fix(VELOCITY_X); -NODES[12599].Fix(VELOCITY_Y); -NODES[12599].Fix(VELOCITY_Z); -NODES[12602].Fix(VELOCITY_X); -NODES[12602].Fix(VELOCITY_Y); -NODES[12602].Fix(VELOCITY_Z); -NODES[12604].Fix(VELOCITY_X); -NODES[12604].Fix(VELOCITY_Y); -NODES[12604].Fix(VELOCITY_Z); -NODES[12618].Fix(VELOCITY_X); -NODES[12618].Fix(VELOCITY_Y); -NODES[12618].Fix(VELOCITY_Z); -NODES[12621].Fix(VELOCITY_X); -NODES[12621].Fix(VELOCITY_Y); -NODES[12621].Fix(VELOCITY_Z); -NODES[12628].Fix(VELOCITY_X); -NODES[12628].Fix(VELOCITY_Y); -NODES[12628].Fix(VELOCITY_Z); -NODES[12630].Fix(VELOCITY_X); -NODES[12630].Fix(VELOCITY_Y); -NODES[12630].Fix(VELOCITY_Z); -NODES[12632].Fix(VELOCITY_X); -NODES[12632].Fix(VELOCITY_Y); -NODES[12632].Fix(VELOCITY_Z); -NODES[12638].Fix(VELOCITY_X); -NODES[12638].Fix(VELOCITY_Y); -NODES[12638].Fix(VELOCITY_Z); -NODES[12653].Fix(VELOCITY_X); -NODES[12653].Fix(VELOCITY_Y); -NODES[12653].Fix(VELOCITY_Z); -NODES[12663].Fix(VELOCITY_X); -NODES[12663].Fix(VELOCITY_Y); -NODES[12663].Fix(VELOCITY_Z); -NODES[12692].Fix(VELOCITY_X); -NODES[12692].Fix(VELOCITY_Y); -NODES[12692].Fix(VELOCITY_Z); -NODES[12693].Fix(VELOCITY_X); -NODES[12693].Fix(VELOCITY_Y); -NODES[12693].Fix(VELOCITY_Z); -NODES[12697].Fix(VELOCITY_X); -NODES[12697].Fix(VELOCITY_Y); -NODES[12697].Fix(VELOCITY_Z); -NODES[12701].Fix(VELOCITY_X); -NODES[12701].Fix(VELOCITY_Y); -NODES[12701].Fix(VELOCITY_Z); -NODES[12710].Fix(VELOCITY_X); -NODES[12710].Fix(VELOCITY_Y); -NODES[12710].Fix(VELOCITY_Z); -NODES[12716].Fix(VELOCITY_X); -NODES[12716].Fix(VELOCITY_Y); -NODES[12716].Fix(VELOCITY_Z); -NODES[12724].Fix(VELOCITY_X); -NODES[12724].Fix(VELOCITY_Y); -NODES[12724].Fix(VELOCITY_Z); -NODES[12725].Fix(VELOCITY_X); -NODES[12725].Fix(VELOCITY_Y); -NODES[12725].Fix(VELOCITY_Z); -NODES[12727].Fix(VELOCITY_X); -NODES[12727].Fix(VELOCITY_Y); -NODES[12727].Fix(VELOCITY_Z); -NODES[12743].Fix(VELOCITY_X); -NODES[12743].Fix(VELOCITY_Y); -NODES[12743].Fix(VELOCITY_Z); -NODES[12744].Fix(VELOCITY_X); -NODES[12744].Fix(VELOCITY_Y); -NODES[12744].Fix(VELOCITY_Z); -NODES[12760].Fix(VELOCITY_X); -NODES[12760].Fix(VELOCITY_Y); -NODES[12760].Fix(VELOCITY_Z); -NODES[12768].Fix(VELOCITY_X); -NODES[12768].Fix(VELOCITY_Y); -NODES[12768].Fix(VELOCITY_Z); -NODES[12774].Fix(VELOCITY_X); -NODES[12774].Fix(VELOCITY_Y); -NODES[12774].Fix(VELOCITY_Z); -NODES[12775].Fix(VELOCITY_X); -NODES[12775].Fix(VELOCITY_Y); -NODES[12775].Fix(VELOCITY_Z); -NODES[12796].Fix(VELOCITY_X); -NODES[12796].Fix(VELOCITY_Y); -NODES[12796].Fix(VELOCITY_Z); -NODES[12798].Fix(VELOCITY_X); -NODES[12798].Fix(VELOCITY_Y); -NODES[12798].Fix(VELOCITY_Z); -NODES[12810].Fix(VELOCITY_X); -NODES[12810].Fix(VELOCITY_Y); -NODES[12810].Fix(VELOCITY_Z); -NODES[12820].Fix(VELOCITY_X); -NODES[12820].Fix(VELOCITY_Y); -NODES[12820].Fix(VELOCITY_Z); -NODES[12821].Fix(VELOCITY_X); -NODES[12821].Fix(VELOCITY_Y); -NODES[12821].Fix(VELOCITY_Z); -NODES[12832].Fix(VELOCITY_X); -NODES[12832].Fix(VELOCITY_Y); -NODES[12832].Fix(VELOCITY_Z); -NODES[12834].Fix(VELOCITY_X); -NODES[12834].Fix(VELOCITY_Y); -NODES[12834].Fix(VELOCITY_Z); -NODES[12842].Fix(VELOCITY_X); -NODES[12842].Fix(VELOCITY_Y); -NODES[12842].Fix(VELOCITY_Z); -NODES[12852].Fix(VELOCITY_X); -NODES[12852].Fix(VELOCITY_Y); -NODES[12852].Fix(VELOCITY_Z); -NODES[12853].Fix(VELOCITY_X); -NODES[12853].Fix(VELOCITY_Y); -NODES[12853].Fix(VELOCITY_Z); -NODES[12854].Fix(VELOCITY_X); -NODES[12854].Fix(VELOCITY_Y); -NODES[12854].Fix(VELOCITY_Z); -NODES[12860].Fix(VELOCITY_X); -NODES[12860].Fix(VELOCITY_Y); -NODES[12860].Fix(VELOCITY_Z); -NODES[12861].Fix(VELOCITY_X); -NODES[12861].Fix(VELOCITY_Y); -NODES[12861].Fix(VELOCITY_Z); -NODES[12862].Fix(VELOCITY_X); -NODES[12862].Fix(VELOCITY_Y); -NODES[12862].Fix(VELOCITY_Z); -NODES[12863].Fix(VELOCITY_X); -NODES[12863].Fix(VELOCITY_Y); -NODES[12863].Fix(VELOCITY_Z); -NODES[12885].Fix(VELOCITY_X); -NODES[12885].Fix(VELOCITY_Y); -NODES[12885].Fix(VELOCITY_Z); -NODES[12912].Fix(VELOCITY_X); -NODES[12912].Fix(VELOCITY_Y); -NODES[12912].Fix(VELOCITY_Z); -NODES[12914].Fix(VELOCITY_X); -NODES[12914].Fix(VELOCITY_Y); -NODES[12914].Fix(VELOCITY_Z); -NODES[12915].Fix(VELOCITY_X); -NODES[12915].Fix(VELOCITY_Y); -NODES[12915].Fix(VELOCITY_Z); -NODES[12925].Fix(VELOCITY_X); -NODES[12925].Fix(VELOCITY_Y); -NODES[12925].Fix(VELOCITY_Z); -NODES[12941].Fix(VELOCITY_X); -NODES[12941].Fix(VELOCITY_Y); -NODES[12941].Fix(VELOCITY_Z); -NODES[12946].Fix(VELOCITY_X); -NODES[12946].Fix(VELOCITY_Y); -NODES[12946].Fix(VELOCITY_Z); -NODES[12951].Fix(VELOCITY_X); -NODES[12951].Fix(VELOCITY_Y); -NODES[12951].Fix(VELOCITY_Z); -NODES[12954].Fix(VELOCITY_X); -NODES[12954].Fix(VELOCITY_Y); -NODES[12954].Fix(VELOCITY_Z); -NODES[12964].Fix(VELOCITY_X); -NODES[12964].Fix(VELOCITY_Y); -NODES[12964].Fix(VELOCITY_Z); -NODES[12966].Fix(VELOCITY_X); -NODES[12966].Fix(VELOCITY_Y); -NODES[12966].Fix(VELOCITY_Z); -NODES[12968].Fix(VELOCITY_X); -NODES[12968].Fix(VELOCITY_Y); -NODES[12968].Fix(VELOCITY_Z); -NODES[12983].Fix(VELOCITY_X); -NODES[12983].Fix(VELOCITY_Y); -NODES[12983].Fix(VELOCITY_Z); -NODES[12991].Fix(VELOCITY_X); -NODES[12991].Fix(VELOCITY_Y); -NODES[12991].Fix(VELOCITY_Z); -NODES[12999].Fix(VELOCITY_X); -NODES[12999].Fix(VELOCITY_Y); -NODES[12999].Fix(VELOCITY_Z); -NODES[13018].Fix(VELOCITY_X); -NODES[13018].Fix(VELOCITY_Y); -NODES[13018].Fix(VELOCITY_Z); -NODES[13029].Fix(VELOCITY_X); -NODES[13029].Fix(VELOCITY_Y); -NODES[13029].Fix(VELOCITY_Z); -NODES[13033].Fix(VELOCITY_X); -NODES[13033].Fix(VELOCITY_Y); -NODES[13033].Fix(VELOCITY_Z); -NODES[13039].Fix(VELOCITY_X); -NODES[13039].Fix(VELOCITY_Y); -NODES[13039].Fix(VELOCITY_Z); -NODES[13042].Fix(VELOCITY_X); -NODES[13042].Fix(VELOCITY_Y); -NODES[13042].Fix(VELOCITY_Z); -NODES[13054].Fix(VELOCITY_X); -NODES[13054].Fix(VELOCITY_Y); -NODES[13054].Fix(VELOCITY_Z); -NODES[13056].Fix(VELOCITY_X); -NODES[13056].Fix(VELOCITY_Y); -NODES[13056].Fix(VELOCITY_Z); -NODES[13065].Fix(VELOCITY_X); -NODES[13065].Fix(VELOCITY_Y); -NODES[13065].Fix(VELOCITY_Z); -NODES[13073].Fix(VELOCITY_X); -NODES[13073].Fix(VELOCITY_Y); -NODES[13073].Fix(VELOCITY_Z); -NODES[13074].Fix(VELOCITY_X); -NODES[13074].Fix(VELOCITY_Y); -NODES[13074].Fix(VELOCITY_Z); -NODES[13086].Fix(VELOCITY_X); -NODES[13086].Fix(VELOCITY_Y); -NODES[13086].Fix(VELOCITY_Z); -NODES[13087].Fix(VELOCITY_X); -NODES[13087].Fix(VELOCITY_Y); -NODES[13087].Fix(VELOCITY_Z); -NODES[13099].Fix(VELOCITY_X); -NODES[13099].Fix(VELOCITY_Y); -NODES[13099].Fix(VELOCITY_Z); -NODES[13104].Fix(VELOCITY_X); -NODES[13104].Fix(VELOCITY_Y); -NODES[13104].Fix(VELOCITY_Z); -NODES[13105].Fix(VELOCITY_X); -NODES[13105].Fix(VELOCITY_Y); -NODES[13105].Fix(VELOCITY_Z); -NODES[13106].Fix(VELOCITY_X); -NODES[13106].Fix(VELOCITY_Y); -NODES[13106].Fix(VELOCITY_Z); -NODES[13107].Fix(VELOCITY_X); -NODES[13107].Fix(VELOCITY_Y); -NODES[13107].Fix(VELOCITY_Z); -NODES[13114].Fix(VELOCITY_X); -NODES[13114].Fix(VELOCITY_Y); -NODES[13114].Fix(VELOCITY_Z); -NODES[13115].Fix(VELOCITY_X); -NODES[13115].Fix(VELOCITY_Y); -NODES[13115].Fix(VELOCITY_Z); -NODES[13124].Fix(VELOCITY_X); -NODES[13124].Fix(VELOCITY_Y); -NODES[13124].Fix(VELOCITY_Z); -NODES[13128].Fix(VELOCITY_X); -NODES[13128].Fix(VELOCITY_Y); -NODES[13128].Fix(VELOCITY_Z); -NODES[13129].Fix(VELOCITY_X); -NODES[13129].Fix(VELOCITY_Y); -NODES[13129].Fix(VELOCITY_Z); -NODES[13130].Fix(VELOCITY_X); -NODES[13130].Fix(VELOCITY_Y); -NODES[13130].Fix(VELOCITY_Z); -NODES[13131].Fix(VELOCITY_X); -NODES[13131].Fix(VELOCITY_Y); -NODES[13131].Fix(VELOCITY_Z); -NODES[13132].Fix(VELOCITY_X); -NODES[13132].Fix(VELOCITY_Y); -NODES[13132].Fix(VELOCITY_Z); -NODES[13133].Fix(VELOCITY_X); -NODES[13133].Fix(VELOCITY_Y); -NODES[13133].Fix(VELOCITY_Z); -NODES[13151].Fix(VELOCITY_X); -NODES[13151].Fix(VELOCITY_Y); -NODES[13151].Fix(VELOCITY_Z); -NODES[13152].Fix(VELOCITY_X); -NODES[13152].Fix(VELOCITY_Y); -NODES[13152].Fix(VELOCITY_Z); -NODES[13155].Fix(VELOCITY_X); -NODES[13155].Fix(VELOCITY_Y); -NODES[13155].Fix(VELOCITY_Z); -NODES[13165].Fix(VELOCITY_X); -NODES[13165].Fix(VELOCITY_Y); -NODES[13165].Fix(VELOCITY_Z); -NODES[13168].Fix(VELOCITY_X); -NODES[13168].Fix(VELOCITY_Y); -NODES[13168].Fix(VELOCITY_Z); -NODES[13169].Fix(VELOCITY_X); -NODES[13169].Fix(VELOCITY_Y); -NODES[13169].Fix(VELOCITY_Z); -NODES[13191].Fix(VELOCITY_X); -NODES[13191].Fix(VELOCITY_Y); -NODES[13191].Fix(VELOCITY_Z); -NODES[13195].Fix(VELOCITY_X); -NODES[13195].Fix(VELOCITY_Y); -NODES[13195].Fix(VELOCITY_Z); -NODES[13201].Fix(VELOCITY_X); -NODES[13201].Fix(VELOCITY_Y); -NODES[13201].Fix(VELOCITY_Z); -NODES[13202].Fix(VELOCITY_X); -NODES[13202].Fix(VELOCITY_Y); -NODES[13202].Fix(VELOCITY_Z); -NODES[13208].Fix(VELOCITY_X); -NODES[13208].Fix(VELOCITY_Y); -NODES[13208].Fix(VELOCITY_Z); -NODES[13209].Fix(VELOCITY_X); -NODES[13209].Fix(VELOCITY_Y); -NODES[13209].Fix(VELOCITY_Z); -NODES[13216].Fix(VELOCITY_X); -NODES[13216].Fix(VELOCITY_Y); -NODES[13216].Fix(VELOCITY_Z); -NODES[13223].Fix(VELOCITY_X); -NODES[13223].Fix(VELOCITY_Y); -NODES[13223].Fix(VELOCITY_Z); -NODES[13235].Fix(VELOCITY_X); -NODES[13235].Fix(VELOCITY_Y); -NODES[13235].Fix(VELOCITY_Z); -NODES[13236].Fix(VELOCITY_X); -NODES[13236].Fix(VELOCITY_Y); -NODES[13236].Fix(VELOCITY_Z); -NODES[13242].Fix(VELOCITY_X); -NODES[13242].Fix(VELOCITY_Y); -NODES[13242].Fix(VELOCITY_Z); -NODES[13255].Fix(VELOCITY_X); -NODES[13255].Fix(VELOCITY_Y); -NODES[13255].Fix(VELOCITY_Z); -NODES[13260].Fix(VELOCITY_X); -NODES[13260].Fix(VELOCITY_Y); -NODES[13260].Fix(VELOCITY_Z); -NODES[13280].Fix(VELOCITY_X); -NODES[13280].Fix(VELOCITY_Y); -NODES[13280].Fix(VELOCITY_Z); -NODES[13283].Fix(VELOCITY_X); -NODES[13283].Fix(VELOCITY_Y); -NODES[13283].Fix(VELOCITY_Z); -NODES[13289].Fix(VELOCITY_X); -NODES[13289].Fix(VELOCITY_Y); -NODES[13289].Fix(VELOCITY_Z); -NODES[13290].Fix(VELOCITY_X); -NODES[13290].Fix(VELOCITY_Y); -NODES[13290].Fix(VELOCITY_Z); -NODES[13299].Fix(VELOCITY_X); -NODES[13299].Fix(VELOCITY_Y); -NODES[13299].Fix(VELOCITY_Z); -NODES[13312].Fix(VELOCITY_X); -NODES[13312].Fix(VELOCITY_Y); -NODES[13312].Fix(VELOCITY_Z); -NODES[13314].Fix(VELOCITY_X); -NODES[13314].Fix(VELOCITY_Y); -NODES[13314].Fix(VELOCITY_Z); -NODES[13326].Fix(VELOCITY_X); -NODES[13326].Fix(VELOCITY_Y); -NODES[13326].Fix(VELOCITY_Z); -NODES[13338].Fix(VELOCITY_X); -NODES[13338].Fix(VELOCITY_Y); -NODES[13338].Fix(VELOCITY_Z); -NODES[13344].Fix(VELOCITY_X); -NODES[13344].Fix(VELOCITY_Y); -NODES[13344].Fix(VELOCITY_Z); -NODES[13347].Fix(VELOCITY_X); -NODES[13347].Fix(VELOCITY_Y); -NODES[13347].Fix(VELOCITY_Z); -NODES[13348].Fix(VELOCITY_X); -NODES[13348].Fix(VELOCITY_Y); -NODES[13348].Fix(VELOCITY_Z); -NODES[13351].Fix(VELOCITY_X); -NODES[13351].Fix(VELOCITY_Y); -NODES[13351].Fix(VELOCITY_Z); -NODES[13360].Fix(VELOCITY_X); -NODES[13360].Fix(VELOCITY_Y); -NODES[13360].Fix(VELOCITY_Z); -NODES[13367].Fix(VELOCITY_X); -NODES[13367].Fix(VELOCITY_Y); -NODES[13367].Fix(VELOCITY_Z); -NODES[13372].Fix(VELOCITY_X); -NODES[13372].Fix(VELOCITY_Y); -NODES[13372].Fix(VELOCITY_Z); -NODES[13378].Fix(VELOCITY_X); -NODES[13378].Fix(VELOCITY_Y); -NODES[13378].Fix(VELOCITY_Z); -NODES[13388].Fix(VELOCITY_X); -NODES[13388].Fix(VELOCITY_Y); -NODES[13388].Fix(VELOCITY_Z); -NODES[13395].Fix(VELOCITY_X); -NODES[13395].Fix(VELOCITY_Y); -NODES[13395].Fix(VELOCITY_Z); -NODES[13417].Fix(VELOCITY_X); -NODES[13417].Fix(VELOCITY_Y); -NODES[13417].Fix(VELOCITY_Z); -NODES[13420].Fix(VELOCITY_X); -NODES[13420].Fix(VELOCITY_Y); -NODES[13420].Fix(VELOCITY_Z); -NODES[13423].Fix(VELOCITY_X); -NODES[13423].Fix(VELOCITY_Y); -NODES[13423].Fix(VELOCITY_Z); -NODES[13424].Fix(VELOCITY_X); -NODES[13424].Fix(VELOCITY_Y); -NODES[13424].Fix(VELOCITY_Z); -NODES[13425].Fix(VELOCITY_X); -NODES[13425].Fix(VELOCITY_Y); -NODES[13425].Fix(VELOCITY_Z); -NODES[13426].Fix(VELOCITY_X); -NODES[13426].Fix(VELOCITY_Y); -NODES[13426].Fix(VELOCITY_Z); -NODES[13436].Fix(VELOCITY_X); -NODES[13436].Fix(VELOCITY_Y); -NODES[13436].Fix(VELOCITY_Z); -NODES[13437].Fix(VELOCITY_X); -NODES[13437].Fix(VELOCITY_Y); -NODES[13437].Fix(VELOCITY_Z); -NODES[13439].Fix(VELOCITY_X); -NODES[13439].Fix(VELOCITY_Y); -NODES[13439].Fix(VELOCITY_Z); -NODES[13447].Fix(VELOCITY_X); -NODES[13447].Fix(VELOCITY_Y); -NODES[13447].Fix(VELOCITY_Z); -NODES[13452].Fix(VELOCITY_X); -NODES[13452].Fix(VELOCITY_Y); -NODES[13452].Fix(VELOCITY_Z); -NODES[13455].Fix(VELOCITY_X); -NODES[13455].Fix(VELOCITY_Y); -NODES[13455].Fix(VELOCITY_Z); -NODES[13466].Fix(VELOCITY_X); -NODES[13466].Fix(VELOCITY_Y); -NODES[13466].Fix(VELOCITY_Z); -NODES[13469].Fix(VELOCITY_X); -NODES[13469].Fix(VELOCITY_Y); -NODES[13469].Fix(VELOCITY_Z); -NODES[13486].Fix(VELOCITY_X); -NODES[13486].Fix(VELOCITY_Y); -NODES[13486].Fix(VELOCITY_Z); -NODES[13493].Fix(VELOCITY_X); -NODES[13493].Fix(VELOCITY_Y); -NODES[13493].Fix(VELOCITY_Z); -NODES[13497].Fix(VELOCITY_X); -NODES[13497].Fix(VELOCITY_Y); -NODES[13497].Fix(VELOCITY_Z); -NODES[13513].Fix(VELOCITY_X); -NODES[13513].Fix(VELOCITY_Y); -NODES[13513].Fix(VELOCITY_Z); -NODES[13524].Fix(VELOCITY_X); -NODES[13524].Fix(VELOCITY_Y); -NODES[13524].Fix(VELOCITY_Z); -NODES[13531].Fix(VELOCITY_X); -NODES[13531].Fix(VELOCITY_Y); -NODES[13531].Fix(VELOCITY_Z); -NODES[13537].Fix(VELOCITY_X); -NODES[13537].Fix(VELOCITY_Y); -NODES[13537].Fix(VELOCITY_Z); -NODES[13538].Fix(VELOCITY_X); -NODES[13538].Fix(VELOCITY_Y); -NODES[13538].Fix(VELOCITY_Z); -NODES[13540].Fix(VELOCITY_X); -NODES[13540].Fix(VELOCITY_Y); -NODES[13540].Fix(VELOCITY_Z); -NODES[13559].Fix(VELOCITY_X); -NODES[13559].Fix(VELOCITY_Y); -NODES[13559].Fix(VELOCITY_Z); -NODES[13562].Fix(VELOCITY_X); -NODES[13562].Fix(VELOCITY_Y); -NODES[13562].Fix(VELOCITY_Z); -NODES[13568].Fix(VELOCITY_X); -NODES[13568].Fix(VELOCITY_Y); -NODES[13568].Fix(VELOCITY_Z); -NODES[13580].Fix(VELOCITY_X); -NODES[13580].Fix(VELOCITY_Y); -NODES[13580].Fix(VELOCITY_Z); -NODES[13595].Fix(VELOCITY_X); -NODES[13595].Fix(VELOCITY_Y); -NODES[13595].Fix(VELOCITY_Z); -NODES[13601].Fix(VELOCITY_X); -NODES[13601].Fix(VELOCITY_Y); -NODES[13601].Fix(VELOCITY_Z); -NODES[13616].Fix(VELOCITY_X); -NODES[13616].Fix(VELOCITY_Y); -NODES[13616].Fix(VELOCITY_Z); -NODES[13618].Fix(VELOCITY_X); -NODES[13618].Fix(VELOCITY_Y); -NODES[13618].Fix(VELOCITY_Z); -NODES[13620].Fix(VELOCITY_X); -NODES[13620].Fix(VELOCITY_Y); -NODES[13620].Fix(VELOCITY_Z); -NODES[13635].Fix(VELOCITY_X); -NODES[13635].Fix(VELOCITY_Y); -NODES[13635].Fix(VELOCITY_Z); -NODES[13638].Fix(VELOCITY_X); -NODES[13638].Fix(VELOCITY_Y); -NODES[13638].Fix(VELOCITY_Z); -NODES[13650].Fix(VELOCITY_X); -NODES[13650].Fix(VELOCITY_Y); -NODES[13650].Fix(VELOCITY_Z); -NODES[13662].Fix(VELOCITY_X); -NODES[13662].Fix(VELOCITY_Y); -NODES[13662].Fix(VELOCITY_Z); -NODES[13678].Fix(VELOCITY_X); -NODES[13678].Fix(VELOCITY_Y); -NODES[13678].Fix(VELOCITY_Z); -NODES[13679].Fix(VELOCITY_X); -NODES[13679].Fix(VELOCITY_Y); -NODES[13679].Fix(VELOCITY_Z); -NODES[13690].Fix(VELOCITY_X); -NODES[13690].Fix(VELOCITY_Y); -NODES[13690].Fix(VELOCITY_Z); -NODES[13692].Fix(VELOCITY_X); -NODES[13692].Fix(VELOCITY_Y); -NODES[13692].Fix(VELOCITY_Z); -NODES[13696].Fix(VELOCITY_X); -NODES[13696].Fix(VELOCITY_Y); -NODES[13696].Fix(VELOCITY_Z); -NODES[13706].Fix(VELOCITY_X); -NODES[13706].Fix(VELOCITY_Y); -NODES[13706].Fix(VELOCITY_Z); -NODES[13712].Fix(VELOCITY_X); -NODES[13712].Fix(VELOCITY_Y); -NODES[13712].Fix(VELOCITY_Z); -NODES[13714].Fix(VELOCITY_X); -NODES[13714].Fix(VELOCITY_Y); -NODES[13714].Fix(VELOCITY_Z); -NODES[13723].Fix(VELOCITY_X); -NODES[13723].Fix(VELOCITY_Y); -NODES[13723].Fix(VELOCITY_Z); -NODES[13724].Fix(VELOCITY_X); -NODES[13724].Fix(VELOCITY_Y); -NODES[13724].Fix(VELOCITY_Z); -NODES[13725].Fix(VELOCITY_X); -NODES[13725].Fix(VELOCITY_Y); -NODES[13725].Fix(VELOCITY_Z); -NODES[13726].Fix(VELOCITY_X); -NODES[13726].Fix(VELOCITY_Y); -NODES[13726].Fix(VELOCITY_Z); -NODES[13727].Fix(VELOCITY_X); -NODES[13727].Fix(VELOCITY_Y); -NODES[13727].Fix(VELOCITY_Z); -NODES[13728].Fix(VELOCITY_X); -NODES[13728].Fix(VELOCITY_Y); -NODES[13728].Fix(VELOCITY_Z); -NODES[13751].Fix(VELOCITY_X); -NODES[13751].Fix(VELOCITY_Y); -NODES[13751].Fix(VELOCITY_Z); -NODES[13774].Fix(VELOCITY_X); -NODES[13774].Fix(VELOCITY_Y); -NODES[13774].Fix(VELOCITY_Z); -NODES[13796].Fix(VELOCITY_X); -NODES[13796].Fix(VELOCITY_Y); -NODES[13796].Fix(VELOCITY_Z); -NODES[13801].Fix(VELOCITY_X); -NODES[13801].Fix(VELOCITY_Y); -NODES[13801].Fix(VELOCITY_Z); -NODES[13802].Fix(VELOCITY_X); -NODES[13802].Fix(VELOCITY_Y); -NODES[13802].Fix(VELOCITY_Z); -NODES[13821].Fix(VELOCITY_X); -NODES[13821].Fix(VELOCITY_Y); -NODES[13821].Fix(VELOCITY_Z); -NODES[13824].Fix(VELOCITY_X); -NODES[13824].Fix(VELOCITY_Y); -NODES[13824].Fix(VELOCITY_Z); -NODES[13831].Fix(VELOCITY_X); -NODES[13831].Fix(VELOCITY_Y); -NODES[13831].Fix(VELOCITY_Z); -NODES[13833].Fix(VELOCITY_X); -NODES[13833].Fix(VELOCITY_Y); -NODES[13833].Fix(VELOCITY_Z); -NODES[13834].Fix(VELOCITY_X); -NODES[13834].Fix(VELOCITY_Y); -NODES[13834].Fix(VELOCITY_Z); -NODES[13838].Fix(VELOCITY_X); -NODES[13838].Fix(VELOCITY_Y); -NODES[13838].Fix(VELOCITY_Z); -NODES[13843].Fix(VELOCITY_X); -NODES[13843].Fix(VELOCITY_Y); -NODES[13843].Fix(VELOCITY_Z); -NODES[13852].Fix(VELOCITY_X); -NODES[13852].Fix(VELOCITY_Y); -NODES[13852].Fix(VELOCITY_Z); -NODES[13862].Fix(VELOCITY_X); -NODES[13862].Fix(VELOCITY_Y); -NODES[13862].Fix(VELOCITY_Z); -NODES[13865].Fix(VELOCITY_X); -NODES[13865].Fix(VELOCITY_Y); -NODES[13865].Fix(VELOCITY_Z); -NODES[13867].Fix(VELOCITY_X); -NODES[13867].Fix(VELOCITY_Y); -NODES[13867].Fix(VELOCITY_Z); -NODES[13889].Fix(VELOCITY_X); -NODES[13889].Fix(VELOCITY_Y); -NODES[13889].Fix(VELOCITY_Z); -NODES[13890].Fix(VELOCITY_X); -NODES[13890].Fix(VELOCITY_Y); -NODES[13890].Fix(VELOCITY_Z); -NODES[13893].Fix(VELOCITY_X); -NODES[13893].Fix(VELOCITY_Y); -NODES[13893].Fix(VELOCITY_Z); -NODES[13899].Fix(VELOCITY_X); -NODES[13899].Fix(VELOCITY_Y); -NODES[13899].Fix(VELOCITY_Z); -NODES[13904].Fix(VELOCITY_X); -NODES[13904].Fix(VELOCITY_Y); -NODES[13904].Fix(VELOCITY_Z); -NODES[13905].Fix(VELOCITY_X); -NODES[13905].Fix(VELOCITY_Y); -NODES[13905].Fix(VELOCITY_Z); -NODES[13908].Fix(VELOCITY_X); -NODES[13908].Fix(VELOCITY_Y); -NODES[13908].Fix(VELOCITY_Z); -NODES[13909].Fix(VELOCITY_X); -NODES[13909].Fix(VELOCITY_Y); -NODES[13909].Fix(VELOCITY_Z); -NODES[13910].Fix(VELOCITY_X); -NODES[13910].Fix(VELOCITY_Y); -NODES[13910].Fix(VELOCITY_Z); -NODES[13916].Fix(VELOCITY_X); -NODES[13916].Fix(VELOCITY_Y); -NODES[13916].Fix(VELOCITY_Z); -NODES[13918].Fix(VELOCITY_X); -NODES[13918].Fix(VELOCITY_Y); -NODES[13918].Fix(VELOCITY_Z); -NODES[13923].Fix(VELOCITY_X); -NODES[13923].Fix(VELOCITY_Y); -NODES[13923].Fix(VELOCITY_Z); -NODES[13931].Fix(VELOCITY_X); -NODES[13931].Fix(VELOCITY_Y); -NODES[13931].Fix(VELOCITY_Z); -NODES[13932].Fix(VELOCITY_X); -NODES[13932].Fix(VELOCITY_Y); -NODES[13932].Fix(VELOCITY_Z); -NODES[13935].Fix(VELOCITY_X); -NODES[13935].Fix(VELOCITY_Y); -NODES[13935].Fix(VELOCITY_Z); -NODES[13939].Fix(VELOCITY_X); -NODES[13939].Fix(VELOCITY_Y); -NODES[13939].Fix(VELOCITY_Z); -NODES[13945].Fix(VELOCITY_X); -NODES[13945].Fix(VELOCITY_Y); -NODES[13945].Fix(VELOCITY_Z); -NODES[13950].Fix(VELOCITY_X); -NODES[13950].Fix(VELOCITY_Y); -NODES[13950].Fix(VELOCITY_Z); -NODES[13956].Fix(VELOCITY_X); -NODES[13956].Fix(VELOCITY_Y); -NODES[13956].Fix(VELOCITY_Z); -NODES[13977].Fix(VELOCITY_X); -NODES[13977].Fix(VELOCITY_Y); -NODES[13977].Fix(VELOCITY_Z); -NODES[13979].Fix(VELOCITY_X); -NODES[13979].Fix(VELOCITY_Y); -NODES[13979].Fix(VELOCITY_Z); -NODES[13980].Fix(VELOCITY_X); -NODES[13980].Fix(VELOCITY_Y); -NODES[13980].Fix(VELOCITY_Z); -NODES[13987].Fix(VELOCITY_X); -NODES[13987].Fix(VELOCITY_Y); -NODES[13987].Fix(VELOCITY_Z); -NODES[13991].Fix(VELOCITY_X); -NODES[13991].Fix(VELOCITY_Y); -NODES[13991].Fix(VELOCITY_Z); -NODES[14006].Fix(VELOCITY_X); -NODES[14006].Fix(VELOCITY_Y); -NODES[14006].Fix(VELOCITY_Z); -NODES[14007].Fix(VELOCITY_X); -NODES[14007].Fix(VELOCITY_Y); -NODES[14007].Fix(VELOCITY_Z); -NODES[14016].Fix(VELOCITY_X); -NODES[14016].Fix(VELOCITY_Y); -NODES[14016].Fix(VELOCITY_Z); -NODES[14017].Fix(VELOCITY_X); -NODES[14017].Fix(VELOCITY_Y); -NODES[14017].Fix(VELOCITY_Z); -NODES[14034].Fix(VELOCITY_X); -NODES[14034].Fix(VELOCITY_Y); -NODES[14034].Fix(VELOCITY_Z); -NODES[14035].Fix(VELOCITY_X); -NODES[14035].Fix(VELOCITY_Y); -NODES[14035].Fix(VELOCITY_Z); -NODES[14036].Fix(VELOCITY_X); -NODES[14036].Fix(VELOCITY_Y); -NODES[14036].Fix(VELOCITY_Z); -NODES[14037].Fix(VELOCITY_X); -NODES[14037].Fix(VELOCITY_Y); -NODES[14037].Fix(VELOCITY_Z); -NODES[14038].Fix(VELOCITY_X); -NODES[14038].Fix(VELOCITY_Y); -NODES[14038].Fix(VELOCITY_Z); -NODES[14052].Fix(VELOCITY_X); -NODES[14052].Fix(VELOCITY_Y); -NODES[14052].Fix(VELOCITY_Z); -NODES[14054].Fix(VELOCITY_X); -NODES[14054].Fix(VELOCITY_Y); -NODES[14054].Fix(VELOCITY_Z); -NODES[14056].Fix(VELOCITY_X); -NODES[14056].Fix(VELOCITY_Y); -NODES[14056].Fix(VELOCITY_Z); -NODES[14064].Fix(VELOCITY_X); -NODES[14064].Fix(VELOCITY_Y); -NODES[14064].Fix(VELOCITY_Z); -NODES[14073].Fix(VELOCITY_X); -NODES[14073].Fix(VELOCITY_Y); -NODES[14073].Fix(VELOCITY_Z); -NODES[14074].Fix(VELOCITY_X); -NODES[14074].Fix(VELOCITY_Y); -NODES[14074].Fix(VELOCITY_Z); -NODES[14076].Fix(VELOCITY_X); -NODES[14076].Fix(VELOCITY_Y); -NODES[14076].Fix(VELOCITY_Z); -NODES[14091].Fix(VELOCITY_X); -NODES[14091].Fix(VELOCITY_Y); -NODES[14091].Fix(VELOCITY_Z); -NODES[14113].Fix(VELOCITY_X); -NODES[14113].Fix(VELOCITY_Y); -NODES[14113].Fix(VELOCITY_Z); -NODES[14116].Fix(VELOCITY_X); -NODES[14116].Fix(VELOCITY_Y); -NODES[14116].Fix(VELOCITY_Z); -NODES[14121].Fix(VELOCITY_X); -NODES[14121].Fix(VELOCITY_Y); -NODES[14121].Fix(VELOCITY_Z); -NODES[14124].Fix(VELOCITY_X); -NODES[14124].Fix(VELOCITY_Y); -NODES[14124].Fix(VELOCITY_Z); -NODES[14146].Fix(VELOCITY_X); -NODES[14146].Fix(VELOCITY_Y); -NODES[14146].Fix(VELOCITY_Z); -NODES[14167].Fix(VELOCITY_X); -NODES[14167].Fix(VELOCITY_Y); -NODES[14167].Fix(VELOCITY_Z); -NODES[14175].Fix(VELOCITY_X); -NODES[14175].Fix(VELOCITY_Y); -NODES[14175].Fix(VELOCITY_Z); -NODES[14179].Fix(VELOCITY_X); -NODES[14179].Fix(VELOCITY_Y); -NODES[14179].Fix(VELOCITY_Z); -NODES[14189].Fix(VELOCITY_X); -NODES[14189].Fix(VELOCITY_Y); -NODES[14189].Fix(VELOCITY_Z); -NODES[14197].Fix(VELOCITY_X); -NODES[14197].Fix(VELOCITY_Y); -NODES[14197].Fix(VELOCITY_Z); -NODES[14203].Fix(VELOCITY_X); -NODES[14203].Fix(VELOCITY_Y); -NODES[14203].Fix(VELOCITY_Z); -NODES[14212].Fix(VELOCITY_X); -NODES[14212].Fix(VELOCITY_Y); -NODES[14212].Fix(VELOCITY_Z); -NODES[14225].Fix(VELOCITY_X); -NODES[14225].Fix(VELOCITY_Y); -NODES[14225].Fix(VELOCITY_Z); -NODES[14228].Fix(VELOCITY_X); -NODES[14228].Fix(VELOCITY_Y); -NODES[14228].Fix(VELOCITY_Z); -NODES[14232].Fix(VELOCITY_X); -NODES[14232].Fix(VELOCITY_Y); -NODES[14232].Fix(VELOCITY_Z); -NODES[14235].Fix(VELOCITY_X); -NODES[14235].Fix(VELOCITY_Y); -NODES[14235].Fix(VELOCITY_Z); -NODES[14236].Fix(VELOCITY_X); -NODES[14236].Fix(VELOCITY_Y); -NODES[14236].Fix(VELOCITY_Z); -NODES[14239].Fix(VELOCITY_X); -NODES[14239].Fix(VELOCITY_Y); -NODES[14239].Fix(VELOCITY_Z); -NODES[14242].Fix(VELOCITY_X); -NODES[14242].Fix(VELOCITY_Y); -NODES[14242].Fix(VELOCITY_Z); -NODES[14281].Fix(VELOCITY_X); -NODES[14281].Fix(VELOCITY_Y); -NODES[14281].Fix(VELOCITY_Z); -NODES[14282].Fix(VELOCITY_X); -NODES[14282].Fix(VELOCITY_Y); -NODES[14282].Fix(VELOCITY_Z); -NODES[14284].Fix(VELOCITY_X); -NODES[14284].Fix(VELOCITY_Y); -NODES[14284].Fix(VELOCITY_Z); -NODES[14288].Fix(VELOCITY_X); -NODES[14288].Fix(VELOCITY_Y); -NODES[14288].Fix(VELOCITY_Z); -NODES[14295].Fix(VELOCITY_X); -NODES[14295].Fix(VELOCITY_Y); -NODES[14295].Fix(VELOCITY_Z); -NODES[14303].Fix(VELOCITY_X); -NODES[14303].Fix(VELOCITY_Y); -NODES[14303].Fix(VELOCITY_Z); -NODES[14306].Fix(VELOCITY_X); -NODES[14306].Fix(VELOCITY_Y); -NODES[14306].Fix(VELOCITY_Z); -NODES[14307].Fix(VELOCITY_X); -NODES[14307].Fix(VELOCITY_Y); -NODES[14307].Fix(VELOCITY_Z); -NODES[14308].Fix(VELOCITY_X); -NODES[14308].Fix(VELOCITY_Y); -NODES[14308].Fix(VELOCITY_Z); -NODES[14314].Fix(VELOCITY_X); -NODES[14314].Fix(VELOCITY_Y); -NODES[14314].Fix(VELOCITY_Z); -NODES[14317].Fix(VELOCITY_X); -NODES[14317].Fix(VELOCITY_Y); -NODES[14317].Fix(VELOCITY_Z); -NODES[14323].Fix(VELOCITY_X); -NODES[14323].Fix(VELOCITY_Y); -NODES[14323].Fix(VELOCITY_Z); -NODES[14326].Fix(VELOCITY_X); -NODES[14326].Fix(VELOCITY_Y); -NODES[14326].Fix(VELOCITY_Z); -NODES[14328].Fix(VELOCITY_X); -NODES[14328].Fix(VELOCITY_Y); -NODES[14328].Fix(VELOCITY_Z); -NODES[14344].Fix(VELOCITY_X); -NODES[14344].Fix(VELOCITY_Y); -NODES[14344].Fix(VELOCITY_Z); -NODES[14345].Fix(VELOCITY_X); -NODES[14345].Fix(VELOCITY_Y); -NODES[14345].Fix(VELOCITY_Z); -NODES[14346].Fix(VELOCITY_X); -NODES[14346].Fix(VELOCITY_Y); -NODES[14346].Fix(VELOCITY_Z); -NODES[14347].Fix(VELOCITY_X); -NODES[14347].Fix(VELOCITY_Y); -NODES[14347].Fix(VELOCITY_Z); -NODES[14376].Fix(VELOCITY_X); -NODES[14376].Fix(VELOCITY_Y); -NODES[14376].Fix(VELOCITY_Z); -NODES[14378].Fix(VELOCITY_X); -NODES[14378].Fix(VELOCITY_Y); -NODES[14378].Fix(VELOCITY_Z); -NODES[14385].Fix(VELOCITY_X); -NODES[14385].Fix(VELOCITY_Y); -NODES[14385].Fix(VELOCITY_Z); -NODES[14386].Fix(VELOCITY_X); -NODES[14386].Fix(VELOCITY_Y); -NODES[14386].Fix(VELOCITY_Z); -NODES[14399].Fix(VELOCITY_X); -NODES[14399].Fix(VELOCITY_Y); -NODES[14399].Fix(VELOCITY_Z); -NODES[14402].Fix(VELOCITY_X); -NODES[14402].Fix(VELOCITY_Y); -NODES[14402].Fix(VELOCITY_Z); -NODES[14404].Fix(VELOCITY_X); -NODES[14404].Fix(VELOCITY_Y); -NODES[14404].Fix(VELOCITY_Z); -NODES[14405].Fix(VELOCITY_X); -NODES[14405].Fix(VELOCITY_Y); -NODES[14405].Fix(VELOCITY_Z); -NODES[14410].Fix(VELOCITY_X); -NODES[14410].Fix(VELOCITY_Y); -NODES[14410].Fix(VELOCITY_Z); -NODES[14418].Fix(VELOCITY_X); -NODES[14418].Fix(VELOCITY_Y); -NODES[14418].Fix(VELOCITY_Z); -NODES[14431].Fix(VELOCITY_X); -NODES[14431].Fix(VELOCITY_Y); -NODES[14431].Fix(VELOCITY_Z); -NODES[14442].Fix(VELOCITY_X); -NODES[14442].Fix(VELOCITY_Y); -NODES[14442].Fix(VELOCITY_Z); -NODES[14449].Fix(VELOCITY_X); -NODES[14449].Fix(VELOCITY_Y); -NODES[14449].Fix(VELOCITY_Z); -NODES[14450].Fix(VELOCITY_X); -NODES[14450].Fix(VELOCITY_Y); -NODES[14450].Fix(VELOCITY_Z); -NODES[14459].Fix(VELOCITY_X); -NODES[14459].Fix(VELOCITY_Y); -NODES[14459].Fix(VELOCITY_Z); -NODES[14473].Fix(VELOCITY_X); -NODES[14473].Fix(VELOCITY_Y); -NODES[14473].Fix(VELOCITY_Z); -NODES[14519].Fix(VELOCITY_X); -NODES[14519].Fix(VELOCITY_Y); -NODES[14519].Fix(VELOCITY_Z); -NODES[14522].Fix(VELOCITY_X); -NODES[14522].Fix(VELOCITY_Y); -NODES[14522].Fix(VELOCITY_Z); -NODES[14524].Fix(VELOCITY_X); -NODES[14524].Fix(VELOCITY_Y); -NODES[14524].Fix(VELOCITY_Z); -NODES[14532].Fix(VELOCITY_X); -NODES[14532].Fix(VELOCITY_Y); -NODES[14532].Fix(VELOCITY_Z); -NODES[14536].Fix(VELOCITY_X); -NODES[14536].Fix(VELOCITY_Y); -NODES[14536].Fix(VELOCITY_Z); -NODES[14542].Fix(VELOCITY_X); -NODES[14542].Fix(VELOCITY_Y); -NODES[14542].Fix(VELOCITY_Z); -NODES[14551].Fix(VELOCITY_X); -NODES[14551].Fix(VELOCITY_Y); -NODES[14551].Fix(VELOCITY_Z); -NODES[14552].Fix(VELOCITY_X); -NODES[14552].Fix(VELOCITY_Y); -NODES[14552].Fix(VELOCITY_Z); -NODES[14556].Fix(VELOCITY_X); -NODES[14556].Fix(VELOCITY_Y); -NODES[14556].Fix(VELOCITY_Z); -NODES[14558].Fix(VELOCITY_X); -NODES[14558].Fix(VELOCITY_Y); -NODES[14558].Fix(VELOCITY_Z); -NODES[14563].Fix(VELOCITY_X); -NODES[14563].Fix(VELOCITY_Y); -NODES[14563].Fix(VELOCITY_Z); -NODES[14590].Fix(VELOCITY_X); -NODES[14590].Fix(VELOCITY_Y); -NODES[14590].Fix(VELOCITY_Z); -NODES[14605].Fix(VELOCITY_X); -NODES[14605].Fix(VELOCITY_Y); -NODES[14605].Fix(VELOCITY_Z); -NODES[14609].Fix(VELOCITY_X); -NODES[14609].Fix(VELOCITY_Y); -NODES[14609].Fix(VELOCITY_Z); -NODES[14619].Fix(VELOCITY_X); -NODES[14619].Fix(VELOCITY_Y); -NODES[14619].Fix(VELOCITY_Z); -NODES[14620].Fix(VELOCITY_X); -NODES[14620].Fix(VELOCITY_Y); -NODES[14620].Fix(VELOCITY_Z); -NODES[14644].Fix(VELOCITY_X); -NODES[14644].Fix(VELOCITY_Y); -NODES[14644].Fix(VELOCITY_Z); -NODES[14646].Fix(VELOCITY_X); -NODES[14646].Fix(VELOCITY_Y); -NODES[14646].Fix(VELOCITY_Z); -NODES[14660].Fix(VELOCITY_X); -NODES[14660].Fix(VELOCITY_Y); -NODES[14660].Fix(VELOCITY_Z); -NODES[14662].Fix(VELOCITY_X); -NODES[14662].Fix(VELOCITY_Y); -NODES[14662].Fix(VELOCITY_Z); -NODES[14663].Fix(VELOCITY_X); -NODES[14663].Fix(VELOCITY_Y); -NODES[14663].Fix(VELOCITY_Z); -NODES[14668].Fix(VELOCITY_X); -NODES[14668].Fix(VELOCITY_Y); -NODES[14668].Fix(VELOCITY_Z); -NODES[14669].Fix(VELOCITY_X); -NODES[14669].Fix(VELOCITY_Y); -NODES[14669].Fix(VELOCITY_Z); -NODES[14680].Fix(VELOCITY_X); -NODES[14680].Fix(VELOCITY_Y); -NODES[14680].Fix(VELOCITY_Z); -NODES[14681].Fix(VELOCITY_X); -NODES[14681].Fix(VELOCITY_Y); -NODES[14681].Fix(VELOCITY_Z); -NODES[14682].Fix(VELOCITY_X); -NODES[14682].Fix(VELOCITY_Y); -NODES[14682].Fix(VELOCITY_Z); -NODES[14683].Fix(VELOCITY_X); -NODES[14683].Fix(VELOCITY_Y); -NODES[14683].Fix(VELOCITY_Z); -NODES[14684].Fix(VELOCITY_X); -NODES[14684].Fix(VELOCITY_Y); -NODES[14684].Fix(VELOCITY_Z); -NODES[14689].Fix(VELOCITY_X); -NODES[14689].Fix(VELOCITY_Y); -NODES[14689].Fix(VELOCITY_Z); -NODES[14690].Fix(VELOCITY_X); -NODES[14690].Fix(VELOCITY_Y); -NODES[14690].Fix(VELOCITY_Z); -NODES[14705].Fix(VELOCITY_X); -NODES[14705].Fix(VELOCITY_Y); -NODES[14705].Fix(VELOCITY_Z); -NODES[14719].Fix(VELOCITY_X); -NODES[14719].Fix(VELOCITY_Y); -NODES[14719].Fix(VELOCITY_Z); -NODES[14723].Fix(VELOCITY_X); -NODES[14723].Fix(VELOCITY_Y); -NODES[14723].Fix(VELOCITY_Z); -NODES[14726].Fix(VELOCITY_X); -NODES[14726].Fix(VELOCITY_Y); -NODES[14726].Fix(VELOCITY_Z); -NODES[14731].Fix(VELOCITY_X); -NODES[14731].Fix(VELOCITY_Y); -NODES[14731].Fix(VELOCITY_Z); -NODES[14732].Fix(VELOCITY_X); -NODES[14732].Fix(VELOCITY_Y); -NODES[14732].Fix(VELOCITY_Z); -NODES[14734].Fix(VELOCITY_X); -NODES[14734].Fix(VELOCITY_Y); -NODES[14734].Fix(VELOCITY_Z); -NODES[14736].Fix(VELOCITY_X); -NODES[14736].Fix(VELOCITY_Y); -NODES[14736].Fix(VELOCITY_Z); -NODES[14737].Fix(VELOCITY_X); -NODES[14737].Fix(VELOCITY_Y); -NODES[14737].Fix(VELOCITY_Z); -NODES[14745].Fix(VELOCITY_X); -NODES[14745].Fix(VELOCITY_Y); -NODES[14745].Fix(VELOCITY_Z); -NODES[14750].Fix(VELOCITY_X); -NODES[14750].Fix(VELOCITY_Y); -NODES[14750].Fix(VELOCITY_Z); -NODES[14763].Fix(VELOCITY_X); -NODES[14763].Fix(VELOCITY_Y); -NODES[14763].Fix(VELOCITY_Z); -NODES[14765].Fix(VELOCITY_X); -NODES[14765].Fix(VELOCITY_Y); -NODES[14765].Fix(VELOCITY_Z); -NODES[14766].Fix(VELOCITY_X); -NODES[14766].Fix(VELOCITY_Y); -NODES[14766].Fix(VELOCITY_Z); -NODES[14768].Fix(VELOCITY_X); -NODES[14768].Fix(VELOCITY_Y); -NODES[14768].Fix(VELOCITY_Z); -NODES[14776].Fix(VELOCITY_X); -NODES[14776].Fix(VELOCITY_Y); -NODES[14776].Fix(VELOCITY_Z); -NODES[14782].Fix(VELOCITY_X); -NODES[14782].Fix(VELOCITY_Y); -NODES[14782].Fix(VELOCITY_Z); -NODES[14792].Fix(VELOCITY_X); -NODES[14792].Fix(VELOCITY_Y); -NODES[14792].Fix(VELOCITY_Z); -NODES[14794].Fix(VELOCITY_X); -NODES[14794].Fix(VELOCITY_Y); -NODES[14794].Fix(VELOCITY_Z); -NODES[14797].Fix(VELOCITY_X); -NODES[14797].Fix(VELOCITY_Y); -NODES[14797].Fix(VELOCITY_Z); -NODES[14800].Fix(VELOCITY_X); -NODES[14800].Fix(VELOCITY_Y); -NODES[14800].Fix(VELOCITY_Z); -NODES[14813].Fix(VELOCITY_X); -NODES[14813].Fix(VELOCITY_Y); -NODES[14813].Fix(VELOCITY_Z); -NODES[14817].Fix(VELOCITY_X); -NODES[14817].Fix(VELOCITY_Y); -NODES[14817].Fix(VELOCITY_Z); -NODES[14823].Fix(VELOCITY_X); -NODES[14823].Fix(VELOCITY_Y); -NODES[14823].Fix(VELOCITY_Z); -NODES[14833].Fix(VELOCITY_X); -NODES[14833].Fix(VELOCITY_Y); -NODES[14833].Fix(VELOCITY_Z); -NODES[14838].Fix(VELOCITY_X); -NODES[14838].Fix(VELOCITY_Y); -NODES[14838].Fix(VELOCITY_Z); -NODES[14841].Fix(VELOCITY_X); -NODES[14841].Fix(VELOCITY_Y); -NODES[14841].Fix(VELOCITY_Z); -NODES[14852].Fix(VELOCITY_X); -NODES[14852].Fix(VELOCITY_Y); -NODES[14852].Fix(VELOCITY_Z); -NODES[14884].Fix(VELOCITY_X); -NODES[14884].Fix(VELOCITY_Y); -NODES[14884].Fix(VELOCITY_Z); -NODES[14889].Fix(VELOCITY_X); -NODES[14889].Fix(VELOCITY_Y); -NODES[14889].Fix(VELOCITY_Z); -NODES[14893].Fix(VELOCITY_X); -NODES[14893].Fix(VELOCITY_Y); -NODES[14893].Fix(VELOCITY_Z); -NODES[14895].Fix(VELOCITY_X); -NODES[14895].Fix(VELOCITY_Y); -NODES[14895].Fix(VELOCITY_Z); -NODES[14899].Fix(VELOCITY_X); -NODES[14899].Fix(VELOCITY_Y); -NODES[14899].Fix(VELOCITY_Z); -NODES[14906].Fix(VELOCITY_X); -NODES[14906].Fix(VELOCITY_Y); -NODES[14906].Fix(VELOCITY_Z); -NODES[14911].Fix(VELOCITY_X); -NODES[14911].Fix(VELOCITY_Y); -NODES[14911].Fix(VELOCITY_Z); -NODES[14912].Fix(VELOCITY_X); -NODES[14912].Fix(VELOCITY_Y); -NODES[14912].Fix(VELOCITY_Z); -NODES[14913].Fix(VELOCITY_X); -NODES[14913].Fix(VELOCITY_Y); -NODES[14913].Fix(VELOCITY_Z); -NODES[14922].Fix(VELOCITY_X); -NODES[14922].Fix(VELOCITY_Y); -NODES[14922].Fix(VELOCITY_Z); -NODES[14928].Fix(VELOCITY_X); -NODES[14928].Fix(VELOCITY_Y); -NODES[14928].Fix(VELOCITY_Z); -NODES[14964].Fix(VELOCITY_X); -NODES[14964].Fix(VELOCITY_Y); -NODES[14964].Fix(VELOCITY_Z); -NODES[14977].Fix(VELOCITY_X); -NODES[14977].Fix(VELOCITY_Y); -NODES[14977].Fix(VELOCITY_Z); -NODES[14984].Fix(VELOCITY_X); -NODES[14984].Fix(VELOCITY_Y); -NODES[14984].Fix(VELOCITY_Z); -NODES[14988].Fix(VELOCITY_X); -NODES[14988].Fix(VELOCITY_Y); -NODES[14988].Fix(VELOCITY_Z); -NODES[14989].Fix(VELOCITY_X); -NODES[14989].Fix(VELOCITY_Y); -NODES[14989].Fix(VELOCITY_Z); -NODES[14990].Fix(VELOCITY_X); -NODES[14990].Fix(VELOCITY_Y); -NODES[14990].Fix(VELOCITY_Z); -NODES[14991].Fix(VELOCITY_X); -NODES[14991].Fix(VELOCITY_Y); -NODES[14991].Fix(VELOCITY_Z); -NODES[14993].Fix(VELOCITY_X); -NODES[14993].Fix(VELOCITY_Y); -NODES[14993].Fix(VELOCITY_Z); -NODES[14995].Fix(VELOCITY_X); -NODES[14995].Fix(VELOCITY_Y); -NODES[14995].Fix(VELOCITY_Z); -NODES[14999].Fix(VELOCITY_X); -NODES[14999].Fix(VELOCITY_Y); -NODES[14999].Fix(VELOCITY_Z); -NODES[15004].Fix(VELOCITY_X); -NODES[15004].Fix(VELOCITY_Y); -NODES[15004].Fix(VELOCITY_Z); -NODES[15005].Fix(VELOCITY_X); -NODES[15005].Fix(VELOCITY_Y); -NODES[15005].Fix(VELOCITY_Z); -NODES[15027].Fix(VELOCITY_X); -NODES[15027].Fix(VELOCITY_Y); -NODES[15027].Fix(VELOCITY_Z); -NODES[15028].Fix(VELOCITY_X); -NODES[15028].Fix(VELOCITY_Y); -NODES[15028].Fix(VELOCITY_Z); -NODES[15029].Fix(VELOCITY_X); -NODES[15029].Fix(VELOCITY_Y); -NODES[15029].Fix(VELOCITY_Z); -NODES[15032].Fix(VELOCITY_X); -NODES[15032].Fix(VELOCITY_Y); -NODES[15032].Fix(VELOCITY_Z); -NODES[15040].Fix(VELOCITY_X); -NODES[15040].Fix(VELOCITY_Y); -NODES[15040].Fix(VELOCITY_Z); -NODES[15059].Fix(VELOCITY_X); -NODES[15059].Fix(VELOCITY_Y); -NODES[15059].Fix(VELOCITY_Z); -NODES[15065].Fix(VELOCITY_X); -NODES[15065].Fix(VELOCITY_Y); -NODES[15065].Fix(VELOCITY_Z); -NODES[15068].Fix(VELOCITY_X); -NODES[15068].Fix(VELOCITY_Y); -NODES[15068].Fix(VELOCITY_Z); -NODES[15078].Fix(VELOCITY_X); -NODES[15078].Fix(VELOCITY_Y); -NODES[15078].Fix(VELOCITY_Z); -NODES[15084].Fix(VELOCITY_X); -NODES[15084].Fix(VELOCITY_Y); -NODES[15084].Fix(VELOCITY_Z); -NODES[15088].Fix(VELOCITY_X); -NODES[15088].Fix(VELOCITY_Y); -NODES[15088].Fix(VELOCITY_Z); -NODES[15102].Fix(VELOCITY_X); -NODES[15102].Fix(VELOCITY_Y); -NODES[15102].Fix(VELOCITY_Z); -NODES[15103].Fix(VELOCITY_X); -NODES[15103].Fix(VELOCITY_Y); -NODES[15103].Fix(VELOCITY_Z); -NODES[15114].Fix(VELOCITY_X); -NODES[15114].Fix(VELOCITY_Y); -NODES[15114].Fix(VELOCITY_Z); -NODES[15123].Fix(VELOCITY_X); -NODES[15123].Fix(VELOCITY_Y); -NODES[15123].Fix(VELOCITY_Z); -NODES[15133].Fix(VELOCITY_X); -NODES[15133].Fix(VELOCITY_Y); -NODES[15133].Fix(VELOCITY_Z); -NODES[15142].Fix(VELOCITY_X); -NODES[15142].Fix(VELOCITY_Y); -NODES[15142].Fix(VELOCITY_Z); -NODES[15148].Fix(VELOCITY_X); -NODES[15148].Fix(VELOCITY_Y); -NODES[15148].Fix(VELOCITY_Z); -NODES[15149].Fix(VELOCITY_X); -NODES[15149].Fix(VELOCITY_Y); -NODES[15149].Fix(VELOCITY_Z); -NODES[15151].Fix(VELOCITY_X); -NODES[15151].Fix(VELOCITY_Y); -NODES[15151].Fix(VELOCITY_Z); -NODES[15170].Fix(VELOCITY_X); -NODES[15170].Fix(VELOCITY_Y); -NODES[15170].Fix(VELOCITY_Z); -NODES[15176].Fix(VELOCITY_X); -NODES[15176].Fix(VELOCITY_Y); -NODES[15176].Fix(VELOCITY_Z); -NODES[15179].Fix(VELOCITY_X); -NODES[15179].Fix(VELOCITY_Y); -NODES[15179].Fix(VELOCITY_Z); -NODES[15185].Fix(VELOCITY_X); -NODES[15185].Fix(VELOCITY_Y); -NODES[15185].Fix(VELOCITY_Z); -NODES[15190].Fix(VELOCITY_X); -NODES[15190].Fix(VELOCITY_Y); -NODES[15190].Fix(VELOCITY_Z); -NODES[15194].Fix(VELOCITY_X); -NODES[15194].Fix(VELOCITY_Y); -NODES[15194].Fix(VELOCITY_Z); -NODES[15195].Fix(VELOCITY_X); -NODES[15195].Fix(VELOCITY_Y); -NODES[15195].Fix(VELOCITY_Z); -NODES[15198].Fix(VELOCITY_X); -NODES[15198].Fix(VELOCITY_Y); -NODES[15198].Fix(VELOCITY_Z); -NODES[15206].Fix(VELOCITY_X); -NODES[15206].Fix(VELOCITY_Y); -NODES[15206].Fix(VELOCITY_Z); -NODES[15207].Fix(VELOCITY_X); -NODES[15207].Fix(VELOCITY_Y); -NODES[15207].Fix(VELOCITY_Z); -NODES[15218].Fix(VELOCITY_X); -NODES[15218].Fix(VELOCITY_Y); -NODES[15218].Fix(VELOCITY_Z); -NODES[15227].Fix(VELOCITY_X); -NODES[15227].Fix(VELOCITY_Y); -NODES[15227].Fix(VELOCITY_Z); -NODES[15233].Fix(VELOCITY_X); -NODES[15233].Fix(VELOCITY_Y); -NODES[15233].Fix(VELOCITY_Z); -NODES[15253].Fix(VELOCITY_X); -NODES[15253].Fix(VELOCITY_Y); -NODES[15253].Fix(VELOCITY_Z); -NODES[15262].Fix(VELOCITY_X); -NODES[15262].Fix(VELOCITY_Y); -NODES[15262].Fix(VELOCITY_Z); -NODES[15264].Fix(VELOCITY_X); -NODES[15264].Fix(VELOCITY_Y); -NODES[15264].Fix(VELOCITY_Z); -NODES[15265].Fix(VELOCITY_X); -NODES[15265].Fix(VELOCITY_Y); -NODES[15265].Fix(VELOCITY_Z); -NODES[15266].Fix(VELOCITY_X); -NODES[15266].Fix(VELOCITY_Y); -NODES[15266].Fix(VELOCITY_Z); -NODES[15270].Fix(VELOCITY_X); -NODES[15270].Fix(VELOCITY_Y); -NODES[15270].Fix(VELOCITY_Z); -NODES[15273].Fix(VELOCITY_X); -NODES[15273].Fix(VELOCITY_Y); -NODES[15273].Fix(VELOCITY_Z); -NODES[15280].Fix(VELOCITY_X); -NODES[15280].Fix(VELOCITY_Y); -NODES[15280].Fix(VELOCITY_Z); -NODES[15283].Fix(VELOCITY_X); -NODES[15283].Fix(VELOCITY_Y); -NODES[15283].Fix(VELOCITY_Z); -NODES[15285].Fix(VELOCITY_X); -NODES[15285].Fix(VELOCITY_Y); -NODES[15285].Fix(VELOCITY_Z); -NODES[15288].Fix(VELOCITY_X); -NODES[15288].Fix(VELOCITY_Y); -NODES[15288].Fix(VELOCITY_Z); -NODES[15301].Fix(VELOCITY_X); -NODES[15301].Fix(VELOCITY_Y); -NODES[15301].Fix(VELOCITY_Z); -NODES[15309].Fix(VELOCITY_X); -NODES[15309].Fix(VELOCITY_Y); -NODES[15309].Fix(VELOCITY_Z); -NODES[15310].Fix(VELOCITY_X); -NODES[15310].Fix(VELOCITY_Y); -NODES[15310].Fix(VELOCITY_Z); -NODES[15311].Fix(VELOCITY_X); -NODES[15311].Fix(VELOCITY_Y); -NODES[15311].Fix(VELOCITY_Z); -NODES[15330].Fix(VELOCITY_X); -NODES[15330].Fix(VELOCITY_Y); -NODES[15330].Fix(VELOCITY_Z); -NODES[15335].Fix(VELOCITY_X); -NODES[15335].Fix(VELOCITY_Y); -NODES[15335].Fix(VELOCITY_Z); -NODES[15337].Fix(VELOCITY_X); -NODES[15337].Fix(VELOCITY_Y); -NODES[15337].Fix(VELOCITY_Z); -NODES[15342].Fix(VELOCITY_X); -NODES[15342].Fix(VELOCITY_Y); -NODES[15342].Fix(VELOCITY_Z); -NODES[15349].Fix(VELOCITY_X); -NODES[15349].Fix(VELOCITY_Y); -NODES[15349].Fix(VELOCITY_Z); -NODES[15355].Fix(VELOCITY_X); -NODES[15355].Fix(VELOCITY_Y); -NODES[15355].Fix(VELOCITY_Z); -NODES[15356].Fix(VELOCITY_X); -NODES[15356].Fix(VELOCITY_Y); -NODES[15356].Fix(VELOCITY_Z); -NODES[15361].Fix(VELOCITY_X); -NODES[15361].Fix(VELOCITY_Y); -NODES[15361].Fix(VELOCITY_Z); -NODES[15372].Fix(VELOCITY_X); -NODES[15372].Fix(VELOCITY_Y); -NODES[15372].Fix(VELOCITY_Z); -NODES[15375].Fix(VELOCITY_X); -NODES[15375].Fix(VELOCITY_Y); -NODES[15375].Fix(VELOCITY_Z); -NODES[15397].Fix(VELOCITY_X); -NODES[15397].Fix(VELOCITY_Y); -NODES[15397].Fix(VELOCITY_Z); -NODES[15406].Fix(VELOCITY_X); -NODES[15406].Fix(VELOCITY_Y); -NODES[15406].Fix(VELOCITY_Z); -NODES[15408].Fix(VELOCITY_X); -NODES[15408].Fix(VELOCITY_Y); -NODES[15408].Fix(VELOCITY_Z); -NODES[15409].Fix(VELOCITY_X); -NODES[15409].Fix(VELOCITY_Y); -NODES[15409].Fix(VELOCITY_Z); -NODES[15414].Fix(VELOCITY_X); -NODES[15414].Fix(VELOCITY_Y); -NODES[15414].Fix(VELOCITY_Z); -NODES[15418].Fix(VELOCITY_X); -NODES[15418].Fix(VELOCITY_Y); -NODES[15418].Fix(VELOCITY_Z); -NODES[15430].Fix(VELOCITY_X); -NODES[15430].Fix(VELOCITY_Y); -NODES[15430].Fix(VELOCITY_Z); -NODES[15440].Fix(VELOCITY_X); -NODES[15440].Fix(VELOCITY_Y); -NODES[15440].Fix(VELOCITY_Z); -NODES[15447].Fix(VELOCITY_X); -NODES[15447].Fix(VELOCITY_Y); -NODES[15447].Fix(VELOCITY_Z); -NODES[15448].Fix(VELOCITY_X); -NODES[15448].Fix(VELOCITY_Y); -NODES[15448].Fix(VELOCITY_Z); -NODES[15451].Fix(VELOCITY_X); -NODES[15451].Fix(VELOCITY_Y); -NODES[15451].Fix(VELOCITY_Z); -NODES[15460].Fix(VELOCITY_X); -NODES[15460].Fix(VELOCITY_Y); -NODES[15460].Fix(VELOCITY_Z); -NODES[15469].Fix(VELOCITY_X); -NODES[15469].Fix(VELOCITY_Y); -NODES[15469].Fix(VELOCITY_Z); -NODES[15471].Fix(VELOCITY_X); -NODES[15471].Fix(VELOCITY_Y); -NODES[15471].Fix(VELOCITY_Z); -NODES[15472].Fix(VELOCITY_X); -NODES[15472].Fix(VELOCITY_Y); -NODES[15472].Fix(VELOCITY_Z); -NODES[15481].Fix(VELOCITY_X); -NODES[15481].Fix(VELOCITY_Y); -NODES[15481].Fix(VELOCITY_Z); -NODES[15482].Fix(VELOCITY_X); -NODES[15482].Fix(VELOCITY_Y); -NODES[15482].Fix(VELOCITY_Z); -NODES[15501].Fix(VELOCITY_X); -NODES[15501].Fix(VELOCITY_Y); -NODES[15501].Fix(VELOCITY_Z); -NODES[15504].Fix(VELOCITY_X); -NODES[15504].Fix(VELOCITY_Y); -NODES[15504].Fix(VELOCITY_Z); -NODES[15512].Fix(VELOCITY_X); -NODES[15512].Fix(VELOCITY_Y); -NODES[15512].Fix(VELOCITY_Z); -NODES[15518].Fix(VELOCITY_X); -NODES[15518].Fix(VELOCITY_Y); -NODES[15518].Fix(VELOCITY_Z); -NODES[15521].Fix(VELOCITY_X); -NODES[15521].Fix(VELOCITY_Y); -NODES[15521].Fix(VELOCITY_Z); -NODES[15529].Fix(VELOCITY_X); -NODES[15529].Fix(VELOCITY_Y); -NODES[15529].Fix(VELOCITY_Z); -NODES[15540].Fix(VELOCITY_X); -NODES[15540].Fix(VELOCITY_Y); -NODES[15540].Fix(VELOCITY_Z); -NODES[15542].Fix(VELOCITY_X); -NODES[15542].Fix(VELOCITY_Y); -NODES[15542].Fix(VELOCITY_Z); -NODES[15544].Fix(VELOCITY_X); -NODES[15544].Fix(VELOCITY_Y); -NODES[15544].Fix(VELOCITY_Z); -NODES[15546].Fix(VELOCITY_X); -NODES[15546].Fix(VELOCITY_Y); -NODES[15546].Fix(VELOCITY_Z); -NODES[15551].Fix(VELOCITY_X); -NODES[15551].Fix(VELOCITY_Y); -NODES[15551].Fix(VELOCITY_Z); -NODES[15552].Fix(VELOCITY_X); -NODES[15552].Fix(VELOCITY_Y); -NODES[15552].Fix(VELOCITY_Z); -NODES[15554].Fix(VELOCITY_X); -NODES[15554].Fix(VELOCITY_Y); -NODES[15554].Fix(VELOCITY_Z); -NODES[15560].Fix(VELOCITY_X); -NODES[15560].Fix(VELOCITY_Y); -NODES[15560].Fix(VELOCITY_Z); -NODES[15561].Fix(VELOCITY_X); -NODES[15561].Fix(VELOCITY_Y); -NODES[15561].Fix(VELOCITY_Z); -NODES[15583].Fix(VELOCITY_X); -NODES[15583].Fix(VELOCITY_Y); -NODES[15583].Fix(VELOCITY_Z); -NODES[15595].Fix(VELOCITY_X); -NODES[15595].Fix(VELOCITY_Y); -NODES[15595].Fix(VELOCITY_Z); -NODES[15597].Fix(VELOCITY_X); -NODES[15597].Fix(VELOCITY_Y); -NODES[15597].Fix(VELOCITY_Z); -NODES[15601].Fix(VELOCITY_X); -NODES[15601].Fix(VELOCITY_Y); -NODES[15601].Fix(VELOCITY_Z); -NODES[15602].Fix(VELOCITY_X); -NODES[15602].Fix(VELOCITY_Y); -NODES[15602].Fix(VELOCITY_Z); -NODES[15607].Fix(VELOCITY_X); -NODES[15607].Fix(VELOCITY_Y); -NODES[15607].Fix(VELOCITY_Z); -NODES[15608].Fix(VELOCITY_X); -NODES[15608].Fix(VELOCITY_Y); -NODES[15608].Fix(VELOCITY_Z); -NODES[15613].Fix(VELOCITY_X); -NODES[15613].Fix(VELOCITY_Y); -NODES[15613].Fix(VELOCITY_Z); -NODES[15618].Fix(VELOCITY_X); -NODES[15618].Fix(VELOCITY_Y); -NODES[15618].Fix(VELOCITY_Z); -NODES[15619].Fix(VELOCITY_X); -NODES[15619].Fix(VELOCITY_Y); -NODES[15619].Fix(VELOCITY_Z); -NODES[15620].Fix(VELOCITY_X); -NODES[15620].Fix(VELOCITY_Y); -NODES[15620].Fix(VELOCITY_Z); -NODES[15621].Fix(VELOCITY_X); -NODES[15621].Fix(VELOCITY_Y); -NODES[15621].Fix(VELOCITY_Z); -NODES[15623].Fix(VELOCITY_X); -NODES[15623].Fix(VELOCITY_Y); -NODES[15623].Fix(VELOCITY_Z); -NODES[15646].Fix(VELOCITY_X); -NODES[15646].Fix(VELOCITY_Y); -NODES[15646].Fix(VELOCITY_Z); -NODES[15659].Fix(VELOCITY_X); -NODES[15659].Fix(VELOCITY_Y); -NODES[15659].Fix(VELOCITY_Z); -NODES[15660].Fix(VELOCITY_X); -NODES[15660].Fix(VELOCITY_Y); -NODES[15660].Fix(VELOCITY_Z); -NODES[15661].Fix(VELOCITY_X); -NODES[15661].Fix(VELOCITY_Y); -NODES[15661].Fix(VELOCITY_Z); -NODES[15662].Fix(VELOCITY_X); -NODES[15662].Fix(VELOCITY_Y); -NODES[15662].Fix(VELOCITY_Z); -NODES[15663].Fix(VELOCITY_X); -NODES[15663].Fix(VELOCITY_Y); -NODES[15663].Fix(VELOCITY_Z); -NODES[15681].Fix(VELOCITY_X); -NODES[15681].Fix(VELOCITY_Y); -NODES[15681].Fix(VELOCITY_Z); -NODES[15698].Fix(VELOCITY_X); -NODES[15698].Fix(VELOCITY_Y); -NODES[15698].Fix(VELOCITY_Z); -NODES[15708].Fix(VELOCITY_X); -NODES[15708].Fix(VELOCITY_Y); -NODES[15708].Fix(VELOCITY_Z); -NODES[15711].Fix(VELOCITY_X); -NODES[15711].Fix(VELOCITY_Y); -NODES[15711].Fix(VELOCITY_Z); -NODES[15723].Fix(VELOCITY_X); -NODES[15723].Fix(VELOCITY_Y); -NODES[15723].Fix(VELOCITY_Z); -NODES[15732].Fix(VELOCITY_X); -NODES[15732].Fix(VELOCITY_Y); -NODES[15732].Fix(VELOCITY_Z); -NODES[15734].Fix(VELOCITY_X); -NODES[15734].Fix(VELOCITY_Y); -NODES[15734].Fix(VELOCITY_Z); -NODES[15743].Fix(VELOCITY_X); -NODES[15743].Fix(VELOCITY_Y); -NODES[15743].Fix(VELOCITY_Z); -NODES[15750].Fix(VELOCITY_X); -NODES[15750].Fix(VELOCITY_Y); -NODES[15750].Fix(VELOCITY_Z); -NODES[15752].Fix(VELOCITY_X); -NODES[15752].Fix(VELOCITY_Y); -NODES[15752].Fix(VELOCITY_Z); -NODES[15764].Fix(VELOCITY_X); -NODES[15764].Fix(VELOCITY_Y); -NODES[15764].Fix(VELOCITY_Z); -NODES[15769].Fix(VELOCITY_X); -NODES[15769].Fix(VELOCITY_Y); -NODES[15769].Fix(VELOCITY_Z); -NODES[15773].Fix(VELOCITY_X); -NODES[15773].Fix(VELOCITY_Y); -NODES[15773].Fix(VELOCITY_Z); -NODES[15777].Fix(VELOCITY_X); -NODES[15777].Fix(VELOCITY_Y); -NODES[15777].Fix(VELOCITY_Z); -NODES[15779].Fix(VELOCITY_X); -NODES[15779].Fix(VELOCITY_Y); -NODES[15779].Fix(VELOCITY_Z); -NODES[15781].Fix(VELOCITY_X); -NODES[15781].Fix(VELOCITY_Y); -NODES[15781].Fix(VELOCITY_Z); -NODES[15785].Fix(VELOCITY_X); -NODES[15785].Fix(VELOCITY_Y); -NODES[15785].Fix(VELOCITY_Z); -NODES[15799].Fix(VELOCITY_X); -NODES[15799].Fix(VELOCITY_Y); -NODES[15799].Fix(VELOCITY_Z); -NODES[15817].Fix(VELOCITY_X); -NODES[15817].Fix(VELOCITY_Y); -NODES[15817].Fix(VELOCITY_Z); -NODES[15819].Fix(VELOCITY_X); -NODES[15819].Fix(VELOCITY_Y); -NODES[15819].Fix(VELOCITY_Z); -NODES[15820].Fix(VELOCITY_X); -NODES[15820].Fix(VELOCITY_Y); -NODES[15820].Fix(VELOCITY_Z); -NODES[15832].Fix(VELOCITY_X); -NODES[15832].Fix(VELOCITY_Y); -NODES[15832].Fix(VELOCITY_Z); -NODES[15844].Fix(VELOCITY_X); -NODES[15844].Fix(VELOCITY_Y); -NODES[15844].Fix(VELOCITY_Z); -NODES[15857].Fix(VELOCITY_X); -NODES[15857].Fix(VELOCITY_Y); -NODES[15857].Fix(VELOCITY_Z); -NODES[15861].Fix(VELOCITY_X); -NODES[15861].Fix(VELOCITY_Y); -NODES[15861].Fix(VELOCITY_Z); -NODES[15863].Fix(VELOCITY_X); -NODES[15863].Fix(VELOCITY_Y); -NODES[15863].Fix(VELOCITY_Z); -NODES[15869].Fix(VELOCITY_X); -NODES[15869].Fix(VELOCITY_Y); -NODES[15869].Fix(VELOCITY_Z); -NODES[15883].Fix(VELOCITY_X); -NODES[15883].Fix(VELOCITY_Y); -NODES[15883].Fix(VELOCITY_Z); -NODES[15890].Fix(VELOCITY_X); -NODES[15890].Fix(VELOCITY_Y); -NODES[15890].Fix(VELOCITY_Z); -NODES[15894].Fix(VELOCITY_X); -NODES[15894].Fix(VELOCITY_Y); -NODES[15894].Fix(VELOCITY_Z); -NODES[15895].Fix(VELOCITY_X); -NODES[15895].Fix(VELOCITY_Y); -NODES[15895].Fix(VELOCITY_Z); -NODES[15896].Fix(VELOCITY_X); -NODES[15896].Fix(VELOCITY_Y); -NODES[15896].Fix(VELOCITY_Z); -NODES[15901].Fix(VELOCITY_X); -NODES[15901].Fix(VELOCITY_Y); -NODES[15901].Fix(VELOCITY_Z); -NODES[15902].Fix(VELOCITY_X); -NODES[15902].Fix(VELOCITY_Y); -NODES[15902].Fix(VELOCITY_Z); -NODES[15912].Fix(VELOCITY_X); -NODES[15912].Fix(VELOCITY_Y); -NODES[15912].Fix(VELOCITY_Z); -NODES[15917].Fix(VELOCITY_X); -NODES[15917].Fix(VELOCITY_Y); -NODES[15917].Fix(VELOCITY_Z); -NODES[15920].Fix(VELOCITY_X); -NODES[15920].Fix(VELOCITY_Y); -NODES[15920].Fix(VELOCITY_Z); -NODES[15923].Fix(VELOCITY_X); -NODES[15923].Fix(VELOCITY_Y); -NODES[15923].Fix(VELOCITY_Z); -NODES[15924].Fix(VELOCITY_X); -NODES[15924].Fix(VELOCITY_Y); -NODES[15924].Fix(VELOCITY_Z); -NODES[15926].Fix(VELOCITY_X); -NODES[15926].Fix(VELOCITY_Y); -NODES[15926].Fix(VELOCITY_Z); -NODES[15932].Fix(VELOCITY_X); -NODES[15932].Fix(VELOCITY_Y); -NODES[15932].Fix(VELOCITY_Z); -NODES[15934].Fix(VELOCITY_X); -NODES[15934].Fix(VELOCITY_Y); -NODES[15934].Fix(VELOCITY_Z); -NODES[15937].Fix(VELOCITY_X); -NODES[15937].Fix(VELOCITY_Y); -NODES[15937].Fix(VELOCITY_Z); -NODES[15938].Fix(VELOCITY_X); -NODES[15938].Fix(VELOCITY_Y); -NODES[15938].Fix(VELOCITY_Z); -NODES[15940].Fix(VELOCITY_X); -NODES[15940].Fix(VELOCITY_Y); -NODES[15940].Fix(VELOCITY_Z); -NODES[15941].Fix(VELOCITY_X); -NODES[15941].Fix(VELOCITY_Y); -NODES[15941].Fix(VELOCITY_Z); -NODES[15966].Fix(VELOCITY_X); -NODES[15966].Fix(VELOCITY_Y); -NODES[15966].Fix(VELOCITY_Z); -NODES[15967].Fix(VELOCITY_X); -NODES[15967].Fix(VELOCITY_Y); -NODES[15967].Fix(VELOCITY_Z); -NODES[15972].Fix(VELOCITY_X); -NODES[15972].Fix(VELOCITY_Y); -NODES[15972].Fix(VELOCITY_Z); -NODES[15980].Fix(VELOCITY_X); -NODES[15980].Fix(VELOCITY_Y); -NODES[15980].Fix(VELOCITY_Z); -NODES[15982].Fix(VELOCITY_X); -NODES[15982].Fix(VELOCITY_Y); -NODES[15982].Fix(VELOCITY_Z); -NODES[15994].Fix(VELOCITY_X); -NODES[15994].Fix(VELOCITY_Y); -NODES[15994].Fix(VELOCITY_Z); -NODES[15995].Fix(VELOCITY_X); -NODES[15995].Fix(VELOCITY_Y); -NODES[15995].Fix(VELOCITY_Z); -NODES[16026].Fix(VELOCITY_X); -NODES[16026].Fix(VELOCITY_Y); -NODES[16026].Fix(VELOCITY_Z); -NODES[16027].Fix(VELOCITY_X); -NODES[16027].Fix(VELOCITY_Y); -NODES[16027].Fix(VELOCITY_Z); -NODES[16028].Fix(VELOCITY_X); -NODES[16028].Fix(VELOCITY_Y); -NODES[16028].Fix(VELOCITY_Z); -NODES[16031].Fix(VELOCITY_X); -NODES[16031].Fix(VELOCITY_Y); -NODES[16031].Fix(VELOCITY_Z); -NODES[16036].Fix(VELOCITY_X); -NODES[16036].Fix(VELOCITY_Y); -NODES[16036].Fix(VELOCITY_Z); -NODES[16037].Fix(VELOCITY_X); -NODES[16037].Fix(VELOCITY_Y); -NODES[16037].Fix(VELOCITY_Z); -NODES[16039].Fix(VELOCITY_X); -NODES[16039].Fix(VELOCITY_Y); -NODES[16039].Fix(VELOCITY_Z); -NODES[16042].Fix(VELOCITY_X); -NODES[16042].Fix(VELOCITY_Y); -NODES[16042].Fix(VELOCITY_Z); -NODES[16047].Fix(VELOCITY_X); -NODES[16047].Fix(VELOCITY_Y); -NODES[16047].Fix(VELOCITY_Z); -NODES[16048].Fix(VELOCITY_X); -NODES[16048].Fix(VELOCITY_Y); -NODES[16048].Fix(VELOCITY_Z); -NODES[16061].Fix(VELOCITY_X); -NODES[16061].Fix(VELOCITY_Y); -NODES[16061].Fix(VELOCITY_Z); -NODES[16062].Fix(VELOCITY_X); -NODES[16062].Fix(VELOCITY_Y); -NODES[16062].Fix(VELOCITY_Z); -NODES[16076].Fix(VELOCITY_X); -NODES[16076].Fix(VELOCITY_Y); -NODES[16076].Fix(VELOCITY_Z); -NODES[16080].Fix(VELOCITY_X); -NODES[16080].Fix(VELOCITY_Y); -NODES[16080].Fix(VELOCITY_Z); -NODES[16083].Fix(VELOCITY_X); -NODES[16083].Fix(VELOCITY_Y); -NODES[16083].Fix(VELOCITY_Z); -NODES[16090].Fix(VELOCITY_X); -NODES[16090].Fix(VELOCITY_Y); -NODES[16090].Fix(VELOCITY_Z); -NODES[16091].Fix(VELOCITY_X); -NODES[16091].Fix(VELOCITY_Y); -NODES[16091].Fix(VELOCITY_Z); -NODES[16111].Fix(VELOCITY_X); -NODES[16111].Fix(VELOCITY_Y); -NODES[16111].Fix(VELOCITY_Z); -NODES[16114].Fix(VELOCITY_X); -NODES[16114].Fix(VELOCITY_Y); -NODES[16114].Fix(VELOCITY_Z); -NODES[16118].Fix(VELOCITY_X); -NODES[16118].Fix(VELOCITY_Y); -NODES[16118].Fix(VELOCITY_Z); -NODES[16127].Fix(VELOCITY_X); -NODES[16127].Fix(VELOCITY_Y); -NODES[16127].Fix(VELOCITY_Z); -NODES[16129].Fix(VELOCITY_X); -NODES[16129].Fix(VELOCITY_Y); -NODES[16129].Fix(VELOCITY_Z); -NODES[16137].Fix(VELOCITY_X); -NODES[16137].Fix(VELOCITY_Y); -NODES[16137].Fix(VELOCITY_Z); -NODES[16144].Fix(VELOCITY_X); -NODES[16144].Fix(VELOCITY_Y); -NODES[16144].Fix(VELOCITY_Z); -NODES[16153].Fix(VELOCITY_X); -NODES[16153].Fix(VELOCITY_Y); -NODES[16153].Fix(VELOCITY_Z); -NODES[16156].Fix(VELOCITY_X); -NODES[16156].Fix(VELOCITY_Y); -NODES[16156].Fix(VELOCITY_Z); -NODES[16161].Fix(VELOCITY_X); -NODES[16161].Fix(VELOCITY_Y); -NODES[16161].Fix(VELOCITY_Z); -NODES[16163].Fix(VELOCITY_X); -NODES[16163].Fix(VELOCITY_Y); -NODES[16163].Fix(VELOCITY_Z); -NODES[16165].Fix(VELOCITY_X); -NODES[16165].Fix(VELOCITY_Y); -NODES[16165].Fix(VELOCITY_Z); -NODES[16168].Fix(VELOCITY_X); -NODES[16168].Fix(VELOCITY_Y); -NODES[16168].Fix(VELOCITY_Z); -NODES[16169].Fix(VELOCITY_X); -NODES[16169].Fix(VELOCITY_Y); -NODES[16169].Fix(VELOCITY_Z); -NODES[16181].Fix(VELOCITY_X); -NODES[16181].Fix(VELOCITY_Y); -NODES[16181].Fix(VELOCITY_Z); -NODES[16196].Fix(VELOCITY_X); -NODES[16196].Fix(VELOCITY_Y); -NODES[16196].Fix(VELOCITY_Z); -NODES[16204].Fix(VELOCITY_X); -NODES[16204].Fix(VELOCITY_Y); -NODES[16204].Fix(VELOCITY_Z); -NODES[16210].Fix(VELOCITY_X); -NODES[16210].Fix(VELOCITY_Y); -NODES[16210].Fix(VELOCITY_Z); -NODES[16216].Fix(VELOCITY_X); -NODES[16216].Fix(VELOCITY_Y); -NODES[16216].Fix(VELOCITY_Z); -NODES[16220].Fix(VELOCITY_X); -NODES[16220].Fix(VELOCITY_Y); -NODES[16220].Fix(VELOCITY_Z); -NODES[16223].Fix(VELOCITY_X); -NODES[16223].Fix(VELOCITY_Y); -NODES[16223].Fix(VELOCITY_Z); -NODES[16224].Fix(VELOCITY_X); -NODES[16224].Fix(VELOCITY_Y); -NODES[16224].Fix(VELOCITY_Z); -NODES[16230].Fix(VELOCITY_X); -NODES[16230].Fix(VELOCITY_Y); -NODES[16230].Fix(VELOCITY_Z); -NODES[16239].Fix(VELOCITY_X); -NODES[16239].Fix(VELOCITY_Y); -NODES[16239].Fix(VELOCITY_Z); -NODES[16244].Fix(VELOCITY_X); -NODES[16244].Fix(VELOCITY_Y); -NODES[16244].Fix(VELOCITY_Z); -NODES[16249].Fix(VELOCITY_X); -NODES[16249].Fix(VELOCITY_Y); -NODES[16249].Fix(VELOCITY_Z); -NODES[16261].Fix(VELOCITY_X); -NODES[16261].Fix(VELOCITY_Y); -NODES[16261].Fix(VELOCITY_Z); -NODES[16262].Fix(VELOCITY_X); -NODES[16262].Fix(VELOCITY_Y); -NODES[16262].Fix(VELOCITY_Z); -NODES[16267].Fix(VELOCITY_X); -NODES[16267].Fix(VELOCITY_Y); -NODES[16267].Fix(VELOCITY_Z); -NODES[16269].Fix(VELOCITY_X); -NODES[16269].Fix(VELOCITY_Y); -NODES[16269].Fix(VELOCITY_Z); -NODES[16291].Fix(VELOCITY_X); -NODES[16291].Fix(VELOCITY_Y); -NODES[16291].Fix(VELOCITY_Z); -NODES[16292].Fix(VELOCITY_X); -NODES[16292].Fix(VELOCITY_Y); -NODES[16292].Fix(VELOCITY_Z); -NODES[16293].Fix(VELOCITY_X); -NODES[16293].Fix(VELOCITY_Y); -NODES[16293].Fix(VELOCITY_Z); -NODES[16296].Fix(VELOCITY_X); -NODES[16296].Fix(VELOCITY_Y); -NODES[16296].Fix(VELOCITY_Z); -NODES[16300].Fix(VELOCITY_X); -NODES[16300].Fix(VELOCITY_Y); -NODES[16300].Fix(VELOCITY_Z); -NODES[16302].Fix(VELOCITY_X); -NODES[16302].Fix(VELOCITY_Y); -NODES[16302].Fix(VELOCITY_Z); -NODES[16310].Fix(VELOCITY_X); -NODES[16310].Fix(VELOCITY_Y); -NODES[16310].Fix(VELOCITY_Z); -NODES[16321].Fix(VELOCITY_X); -NODES[16321].Fix(VELOCITY_Y); -NODES[16321].Fix(VELOCITY_Z); -NODES[16326].Fix(VELOCITY_X); -NODES[16326].Fix(VELOCITY_Y); -NODES[16326].Fix(VELOCITY_Z); -NODES[16329].Fix(VELOCITY_X); -NODES[16329].Fix(VELOCITY_Y); -NODES[16329].Fix(VELOCITY_Z); -NODES[16334].Fix(VELOCITY_X); -NODES[16334].Fix(VELOCITY_Y); -NODES[16334].Fix(VELOCITY_Z); -NODES[16343].Fix(VELOCITY_X); -NODES[16343].Fix(VELOCITY_Y); -NODES[16343].Fix(VELOCITY_Z); -NODES[16344].Fix(VELOCITY_X); -NODES[16344].Fix(VELOCITY_Y); -NODES[16344].Fix(VELOCITY_Z); -NODES[16346].Fix(VELOCITY_X); -NODES[16346].Fix(VELOCITY_Y); -NODES[16346].Fix(VELOCITY_Z); -NODES[16352].Fix(VELOCITY_X); -NODES[16352].Fix(VELOCITY_Y); -NODES[16352].Fix(VELOCITY_Z); -NODES[16353].Fix(VELOCITY_X); -NODES[16353].Fix(VELOCITY_Y); -NODES[16353].Fix(VELOCITY_Z); -NODES[16357].Fix(VELOCITY_X); -NODES[16357].Fix(VELOCITY_Y); -NODES[16357].Fix(VELOCITY_Z); -NODES[16359].Fix(VELOCITY_X); -NODES[16359].Fix(VELOCITY_Y); -NODES[16359].Fix(VELOCITY_Z); -NODES[16376].Fix(VELOCITY_X); -NODES[16376].Fix(VELOCITY_Y); -NODES[16376].Fix(VELOCITY_Z); -NODES[16387].Fix(VELOCITY_X); -NODES[16387].Fix(VELOCITY_Y); -NODES[16387].Fix(VELOCITY_Z); -NODES[16391].Fix(VELOCITY_X); -NODES[16391].Fix(VELOCITY_Y); -NODES[16391].Fix(VELOCITY_Z); -NODES[16392].Fix(VELOCITY_X); -NODES[16392].Fix(VELOCITY_Y); -NODES[16392].Fix(VELOCITY_Z); -NODES[16393].Fix(VELOCITY_X); -NODES[16393].Fix(VELOCITY_Y); -NODES[16393].Fix(VELOCITY_Z); -NODES[16398].Fix(VELOCITY_X); -NODES[16398].Fix(VELOCITY_Y); -NODES[16398].Fix(VELOCITY_Z); -NODES[16406].Fix(VELOCITY_X); -NODES[16406].Fix(VELOCITY_Y); -NODES[16406].Fix(VELOCITY_Z); -NODES[16411].Fix(VELOCITY_X); -NODES[16411].Fix(VELOCITY_Y); -NODES[16411].Fix(VELOCITY_Z); -NODES[16412].Fix(VELOCITY_X); -NODES[16412].Fix(VELOCITY_Y); -NODES[16412].Fix(VELOCITY_Z); -NODES[16413].Fix(VELOCITY_X); -NODES[16413].Fix(VELOCITY_Y); -NODES[16413].Fix(VELOCITY_Z); -NODES[16420].Fix(VELOCITY_X); -NODES[16420].Fix(VELOCITY_Y); -NODES[16420].Fix(VELOCITY_Z); -NODES[16439].Fix(VELOCITY_X); -NODES[16439].Fix(VELOCITY_Y); -NODES[16439].Fix(VELOCITY_Z); -NODES[16442].Fix(VELOCITY_X); -NODES[16442].Fix(VELOCITY_Y); -NODES[16442].Fix(VELOCITY_Z); -NODES[16448].Fix(VELOCITY_X); -NODES[16448].Fix(VELOCITY_Y); -NODES[16448].Fix(VELOCITY_Z); -NODES[16451].Fix(VELOCITY_X); -NODES[16451].Fix(VELOCITY_Y); -NODES[16451].Fix(VELOCITY_Z); -NODES[16460].Fix(VELOCITY_X); -NODES[16460].Fix(VELOCITY_Y); -NODES[16460].Fix(VELOCITY_Z); -NODES[16461].Fix(VELOCITY_X); -NODES[16461].Fix(VELOCITY_Y); -NODES[16461].Fix(VELOCITY_Z); -NODES[16462].Fix(VELOCITY_X); -NODES[16462].Fix(VELOCITY_Y); -NODES[16462].Fix(VELOCITY_Z); -NODES[16478].Fix(VELOCITY_X); -NODES[16478].Fix(VELOCITY_Y); -NODES[16478].Fix(VELOCITY_Z); -NODES[16480].Fix(VELOCITY_X); -NODES[16480].Fix(VELOCITY_Y); -NODES[16480].Fix(VELOCITY_Z); -NODES[16483].Fix(VELOCITY_X); -NODES[16483].Fix(VELOCITY_Y); -NODES[16483].Fix(VELOCITY_Z); -NODES[16494].Fix(VELOCITY_X); -NODES[16494].Fix(VELOCITY_Y); -NODES[16494].Fix(VELOCITY_Z); -NODES[16495].Fix(VELOCITY_X); -NODES[16495].Fix(VELOCITY_Y); -NODES[16495].Fix(VELOCITY_Z); -NODES[16497].Fix(VELOCITY_X); -NODES[16497].Fix(VELOCITY_Y); -NODES[16497].Fix(VELOCITY_Z); -NODES[16501].Fix(VELOCITY_X); -NODES[16501].Fix(VELOCITY_Y); -NODES[16501].Fix(VELOCITY_Z); -NODES[16503].Fix(VELOCITY_X); -NODES[16503].Fix(VELOCITY_Y); -NODES[16503].Fix(VELOCITY_Z); -NODES[16516].Fix(VELOCITY_X); -NODES[16516].Fix(VELOCITY_Y); -NODES[16516].Fix(VELOCITY_Z); -NODES[16526].Fix(VELOCITY_X); -NODES[16526].Fix(VELOCITY_Y); -NODES[16526].Fix(VELOCITY_Z); -NODES[16529].Fix(VELOCITY_X); -NODES[16529].Fix(VELOCITY_Y); -NODES[16529].Fix(VELOCITY_Z); -NODES[16531].Fix(VELOCITY_X); -NODES[16531].Fix(VELOCITY_Y); -NODES[16531].Fix(VELOCITY_Z); -NODES[16532].Fix(VELOCITY_X); -NODES[16532].Fix(VELOCITY_Y); -NODES[16532].Fix(VELOCITY_Z); -NODES[16534].Fix(VELOCITY_X); -NODES[16534].Fix(VELOCITY_Y); -NODES[16534].Fix(VELOCITY_Z); -NODES[16536].Fix(VELOCITY_X); -NODES[16536].Fix(VELOCITY_Y); -NODES[16536].Fix(VELOCITY_Z); -NODES[16539].Fix(VELOCITY_X); -NODES[16539].Fix(VELOCITY_Y); -NODES[16539].Fix(VELOCITY_Z); -NODES[16540].Fix(VELOCITY_X); -NODES[16540].Fix(VELOCITY_Y); -NODES[16540].Fix(VELOCITY_Z); -NODES[16550].Fix(VELOCITY_X); -NODES[16550].Fix(VELOCITY_Y); -NODES[16550].Fix(VELOCITY_Z); -NODES[16553].Fix(VELOCITY_X); -NODES[16553].Fix(VELOCITY_Y); -NODES[16553].Fix(VELOCITY_Z); -NODES[16556].Fix(VELOCITY_X); -NODES[16556].Fix(VELOCITY_Y); -NODES[16556].Fix(VELOCITY_Z); -NODES[16566].Fix(VELOCITY_X); -NODES[16566].Fix(VELOCITY_Y); -NODES[16566].Fix(VELOCITY_Z); -NODES[16569].Fix(VELOCITY_X); -NODES[16569].Fix(VELOCITY_Y); -NODES[16569].Fix(VELOCITY_Z); -NODES[16577].Fix(VELOCITY_X); -NODES[16577].Fix(VELOCITY_Y); -NODES[16577].Fix(VELOCITY_Z); -NODES[16585].Fix(VELOCITY_X); -NODES[16585].Fix(VELOCITY_Y); -NODES[16585].Fix(VELOCITY_Z); -NODES[16586].Fix(VELOCITY_X); -NODES[16586].Fix(VELOCITY_Y); -NODES[16586].Fix(VELOCITY_Z); -NODES[16588].Fix(VELOCITY_X); -NODES[16588].Fix(VELOCITY_Y); -NODES[16588].Fix(VELOCITY_Z); -NODES[16621].Fix(VELOCITY_X); -NODES[16621].Fix(VELOCITY_Y); -NODES[16621].Fix(VELOCITY_Z); -NODES[16628].Fix(VELOCITY_X); -NODES[16628].Fix(VELOCITY_Y); -NODES[16628].Fix(VELOCITY_Z); -NODES[16630].Fix(VELOCITY_X); -NODES[16630].Fix(VELOCITY_Y); -NODES[16630].Fix(VELOCITY_Z); -NODES[16631].Fix(VELOCITY_X); -NODES[16631].Fix(VELOCITY_Y); -NODES[16631].Fix(VELOCITY_Z); -NODES[16632].Fix(VELOCITY_X); -NODES[16632].Fix(VELOCITY_Y); -NODES[16632].Fix(VELOCITY_Z); -NODES[16639].Fix(VELOCITY_X); -NODES[16639].Fix(VELOCITY_Y); -NODES[16639].Fix(VELOCITY_Z); -NODES[16645].Fix(VELOCITY_X); -NODES[16645].Fix(VELOCITY_Y); -NODES[16645].Fix(VELOCITY_Z); -NODES[16647].Fix(VELOCITY_X); -NODES[16647].Fix(VELOCITY_Y); -NODES[16647].Fix(VELOCITY_Z); -NODES[16651].Fix(VELOCITY_X); -NODES[16651].Fix(VELOCITY_Y); -NODES[16651].Fix(VELOCITY_Z); -NODES[16653].Fix(VELOCITY_X); -NODES[16653].Fix(VELOCITY_Y); -NODES[16653].Fix(VELOCITY_Z); -NODES[16662].Fix(VELOCITY_X); -NODES[16662].Fix(VELOCITY_Y); -NODES[16662].Fix(VELOCITY_Z); -NODES[16663].Fix(VELOCITY_X); -NODES[16663].Fix(VELOCITY_Y); -NODES[16663].Fix(VELOCITY_Z); -NODES[16665].Fix(VELOCITY_X); -NODES[16665].Fix(VELOCITY_Y); -NODES[16665].Fix(VELOCITY_Z); -NODES[16679].Fix(VELOCITY_X); -NODES[16679].Fix(VELOCITY_Y); -NODES[16679].Fix(VELOCITY_Z); -NODES[16681].Fix(VELOCITY_X); -NODES[16681].Fix(VELOCITY_Y); -NODES[16681].Fix(VELOCITY_Z); -NODES[16682].Fix(VELOCITY_X); -NODES[16682].Fix(VELOCITY_Y); -NODES[16682].Fix(VELOCITY_Z); -NODES[16688].Fix(VELOCITY_X); -NODES[16688].Fix(VELOCITY_Y); -NODES[16688].Fix(VELOCITY_Z); -NODES[16701].Fix(VELOCITY_X); -NODES[16701].Fix(VELOCITY_Y); -NODES[16701].Fix(VELOCITY_Z); -NODES[16711].Fix(VELOCITY_X); -NODES[16711].Fix(VELOCITY_Y); -NODES[16711].Fix(VELOCITY_Z); -NODES[16716].Fix(VELOCITY_X); -NODES[16716].Fix(VELOCITY_Y); -NODES[16716].Fix(VELOCITY_Z); -NODES[16721].Fix(VELOCITY_X); -NODES[16721].Fix(VELOCITY_Y); -NODES[16721].Fix(VELOCITY_Z); -NODES[16730].Fix(VELOCITY_X); -NODES[16730].Fix(VELOCITY_Y); -NODES[16730].Fix(VELOCITY_Z); -NODES[16733].Fix(VELOCITY_X); -NODES[16733].Fix(VELOCITY_Y); -NODES[16733].Fix(VELOCITY_Z); -NODES[16736].Fix(VELOCITY_X); -NODES[16736].Fix(VELOCITY_Y); -NODES[16736].Fix(VELOCITY_Z); -NODES[16737].Fix(VELOCITY_X); -NODES[16737].Fix(VELOCITY_Y); -NODES[16737].Fix(VELOCITY_Z); -NODES[16742].Fix(VELOCITY_X); -NODES[16742].Fix(VELOCITY_Y); -NODES[16742].Fix(VELOCITY_Z); -NODES[16749].Fix(VELOCITY_X); -NODES[16749].Fix(VELOCITY_Y); -NODES[16749].Fix(VELOCITY_Z); -NODES[16754].Fix(VELOCITY_X); -NODES[16754].Fix(VELOCITY_Y); -NODES[16754].Fix(VELOCITY_Z); -NODES[16762].Fix(VELOCITY_X); -NODES[16762].Fix(VELOCITY_Y); -NODES[16762].Fix(VELOCITY_Z); -NODES[16765].Fix(VELOCITY_X); -NODES[16765].Fix(VELOCITY_Y); -NODES[16765].Fix(VELOCITY_Z); -NODES[16766].Fix(VELOCITY_X); -NODES[16766].Fix(VELOCITY_Y); -NODES[16766].Fix(VELOCITY_Z); -NODES[16774].Fix(VELOCITY_X); -NODES[16774].Fix(VELOCITY_Y); -NODES[16774].Fix(VELOCITY_Z); -NODES[16775].Fix(VELOCITY_X); -NODES[16775].Fix(VELOCITY_Y); -NODES[16775].Fix(VELOCITY_Z); -NODES[16791].Fix(VELOCITY_X); -NODES[16791].Fix(VELOCITY_Y); -NODES[16791].Fix(VELOCITY_Z); -NODES[16797].Fix(VELOCITY_X); -NODES[16797].Fix(VELOCITY_Y); -NODES[16797].Fix(VELOCITY_Z); -NODES[16813].Fix(VELOCITY_X); -NODES[16813].Fix(VELOCITY_Y); -NODES[16813].Fix(VELOCITY_Z); -NODES[16821].Fix(VELOCITY_X); -NODES[16821].Fix(VELOCITY_Y); -NODES[16821].Fix(VELOCITY_Z); -NODES[16823].Fix(VELOCITY_X); -NODES[16823].Fix(VELOCITY_Y); -NODES[16823].Fix(VELOCITY_Z); -NODES[16824].Fix(VELOCITY_X); -NODES[16824].Fix(VELOCITY_Y); -NODES[16824].Fix(VELOCITY_Z); -NODES[16828].Fix(VELOCITY_X); -NODES[16828].Fix(VELOCITY_Y); -NODES[16828].Fix(VELOCITY_Z); -NODES[16829].Fix(VELOCITY_X); -NODES[16829].Fix(VELOCITY_Y); -NODES[16829].Fix(VELOCITY_Z); -NODES[16837].Fix(VELOCITY_X); -NODES[16837].Fix(VELOCITY_Y); -NODES[16837].Fix(VELOCITY_Z); -NODES[16841].Fix(VELOCITY_X); -NODES[16841].Fix(VELOCITY_Y); -NODES[16841].Fix(VELOCITY_Z); -NODES[16844].Fix(VELOCITY_X); -NODES[16844].Fix(VELOCITY_Y); -NODES[16844].Fix(VELOCITY_Z); -NODES[16847].Fix(VELOCITY_X); -NODES[16847].Fix(VELOCITY_Y); -NODES[16847].Fix(VELOCITY_Z); -NODES[16850].Fix(VELOCITY_X); -NODES[16850].Fix(VELOCITY_Y); -NODES[16850].Fix(VELOCITY_Z); -NODES[16851].Fix(VELOCITY_X); -NODES[16851].Fix(VELOCITY_Y); -NODES[16851].Fix(VELOCITY_Z); -NODES[16858].Fix(VELOCITY_X); -NODES[16858].Fix(VELOCITY_Y); -NODES[16858].Fix(VELOCITY_Z); -NODES[16867].Fix(VELOCITY_X); -NODES[16867].Fix(VELOCITY_Y); -NODES[16867].Fix(VELOCITY_Z); -NODES[16874].Fix(VELOCITY_X); -NODES[16874].Fix(VELOCITY_Y); -NODES[16874].Fix(VELOCITY_Z); -NODES[16877].Fix(VELOCITY_X); -NODES[16877].Fix(VELOCITY_Y); -NODES[16877].Fix(VELOCITY_Z); -NODES[16878].Fix(VELOCITY_X); -NODES[16878].Fix(VELOCITY_Y); -NODES[16878].Fix(VELOCITY_Z); -NODES[16879].Fix(VELOCITY_X); -NODES[16879].Fix(VELOCITY_Y); -NODES[16879].Fix(VELOCITY_Z); -NODES[16881].Fix(VELOCITY_X); -NODES[16881].Fix(VELOCITY_Y); -NODES[16881].Fix(VELOCITY_Z); -NODES[16884].Fix(VELOCITY_X); -NODES[16884].Fix(VELOCITY_Y); -NODES[16884].Fix(VELOCITY_Z); -NODES[16887].Fix(VELOCITY_X); -NODES[16887].Fix(VELOCITY_Y); -NODES[16887].Fix(VELOCITY_Z); -NODES[16899].Fix(VELOCITY_X); -NODES[16899].Fix(VELOCITY_Y); -NODES[16899].Fix(VELOCITY_Z); -NODES[16906].Fix(VELOCITY_X); -NODES[16906].Fix(VELOCITY_Y); -NODES[16906].Fix(VELOCITY_Z); -NODES[16907].Fix(VELOCITY_X); -NODES[16907].Fix(VELOCITY_Y); -NODES[16907].Fix(VELOCITY_Z); -NODES[16908].Fix(VELOCITY_X); -NODES[16908].Fix(VELOCITY_Y); -NODES[16908].Fix(VELOCITY_Z); -NODES[16939].Fix(VELOCITY_X); -NODES[16939].Fix(VELOCITY_Y); -NODES[16939].Fix(VELOCITY_Z); -NODES[16940].Fix(VELOCITY_X); -NODES[16940].Fix(VELOCITY_Y); -NODES[16940].Fix(VELOCITY_Z); -NODES[16952].Fix(VELOCITY_X); -NODES[16952].Fix(VELOCITY_Y); -NODES[16952].Fix(VELOCITY_Z); -NODES[16953].Fix(VELOCITY_X); -NODES[16953].Fix(VELOCITY_Y); -NODES[16953].Fix(VELOCITY_Z); -NODES[16955].Fix(VELOCITY_X); -NODES[16955].Fix(VELOCITY_Y); -NODES[16955].Fix(VELOCITY_Z); -NODES[16962].Fix(VELOCITY_X); -NODES[16962].Fix(VELOCITY_Y); -NODES[16962].Fix(VELOCITY_Z); -NODES[16966].Fix(VELOCITY_X); -NODES[16966].Fix(VELOCITY_Y); -NODES[16966].Fix(VELOCITY_Z); -NODES[16970].Fix(VELOCITY_X); -NODES[16970].Fix(VELOCITY_Y); -NODES[16970].Fix(VELOCITY_Z); -NODES[16974].Fix(VELOCITY_X); -NODES[16974].Fix(VELOCITY_Y); -NODES[16974].Fix(VELOCITY_Z); -NODES[16986].Fix(VELOCITY_X); -NODES[16986].Fix(VELOCITY_Y); -NODES[16986].Fix(VELOCITY_Z); -NODES[16990].Fix(VELOCITY_X); -NODES[16990].Fix(VELOCITY_Y); -NODES[16990].Fix(VELOCITY_Z); -NODES[16993].Fix(VELOCITY_X); -NODES[16993].Fix(VELOCITY_Y); -NODES[16993].Fix(VELOCITY_Z); -NODES[16995].Fix(VELOCITY_X); -NODES[16995].Fix(VELOCITY_Y); -NODES[16995].Fix(VELOCITY_Z); -NODES[16996].Fix(VELOCITY_X); -NODES[16996].Fix(VELOCITY_Y); -NODES[16996].Fix(VELOCITY_Z); -NODES[16997].Fix(VELOCITY_X); -NODES[16997].Fix(VELOCITY_Y); -NODES[16997].Fix(VELOCITY_Z); -NODES[17000].Fix(VELOCITY_X); -NODES[17000].Fix(VELOCITY_Y); -NODES[17000].Fix(VELOCITY_Z); -NODES[17009].Fix(VELOCITY_X); -NODES[17009].Fix(VELOCITY_Y); -NODES[17009].Fix(VELOCITY_Z); -NODES[17010].Fix(VELOCITY_X); -NODES[17010].Fix(VELOCITY_Y); -NODES[17010].Fix(VELOCITY_Z); -NODES[17015].Fix(VELOCITY_X); -NODES[17015].Fix(VELOCITY_Y); -NODES[17015].Fix(VELOCITY_Z); -NODES[17016].Fix(VELOCITY_X); -NODES[17016].Fix(VELOCITY_Y); -NODES[17016].Fix(VELOCITY_Z); -NODES[17029].Fix(VELOCITY_X); -NODES[17029].Fix(VELOCITY_Y); -NODES[17029].Fix(VELOCITY_Z); -NODES[17030].Fix(VELOCITY_X); -NODES[17030].Fix(VELOCITY_Y); -NODES[17030].Fix(VELOCITY_Z); -NODES[17034].Fix(VELOCITY_X); -NODES[17034].Fix(VELOCITY_Y); -NODES[17034].Fix(VELOCITY_Z); -NODES[17039].Fix(VELOCITY_X); -NODES[17039].Fix(VELOCITY_Y); -NODES[17039].Fix(VELOCITY_Z); -NODES[17042].Fix(VELOCITY_X); -NODES[17042].Fix(VELOCITY_Y); -NODES[17042].Fix(VELOCITY_Z); -NODES[17043].Fix(VELOCITY_X); -NODES[17043].Fix(VELOCITY_Y); -NODES[17043].Fix(VELOCITY_Z); -NODES[17047].Fix(VELOCITY_X); -NODES[17047].Fix(VELOCITY_Y); -NODES[17047].Fix(VELOCITY_Z); -NODES[17055].Fix(VELOCITY_X); -NODES[17055].Fix(VELOCITY_Y); -NODES[17055].Fix(VELOCITY_Z); -NODES[17062].Fix(VELOCITY_X); -NODES[17062].Fix(VELOCITY_Y); -NODES[17062].Fix(VELOCITY_Z); -NODES[17064].Fix(VELOCITY_X); -NODES[17064].Fix(VELOCITY_Y); -NODES[17064].Fix(VELOCITY_Z); -NODES[17072].Fix(VELOCITY_X); -NODES[17072].Fix(VELOCITY_Y); -NODES[17072].Fix(VELOCITY_Z); -NODES[17077].Fix(VELOCITY_X); -NODES[17077].Fix(VELOCITY_Y); -NODES[17077].Fix(VELOCITY_Z); -NODES[17081].Fix(VELOCITY_X); -NODES[17081].Fix(VELOCITY_Y); -NODES[17081].Fix(VELOCITY_Z); -NODES[17092].Fix(VELOCITY_X); -NODES[17092].Fix(VELOCITY_Y); -NODES[17092].Fix(VELOCITY_Z); -NODES[17093].Fix(VELOCITY_X); -NODES[17093].Fix(VELOCITY_Y); -NODES[17093].Fix(VELOCITY_Z); -NODES[17104].Fix(VELOCITY_X); -NODES[17104].Fix(VELOCITY_Y); -NODES[17104].Fix(VELOCITY_Z); -NODES[17106].Fix(VELOCITY_X); -NODES[17106].Fix(VELOCITY_Y); -NODES[17106].Fix(VELOCITY_Z); -NODES[17110].Fix(VELOCITY_X); -NODES[17110].Fix(VELOCITY_Y); -NODES[17110].Fix(VELOCITY_Z); -NODES[17111].Fix(VELOCITY_X); -NODES[17111].Fix(VELOCITY_Y); -NODES[17111].Fix(VELOCITY_Z); -NODES[17112].Fix(VELOCITY_X); -NODES[17112].Fix(VELOCITY_Y); -NODES[17112].Fix(VELOCITY_Z); -NODES[17115].Fix(VELOCITY_X); -NODES[17115].Fix(VELOCITY_Y); -NODES[17115].Fix(VELOCITY_Z); -NODES[17124].Fix(VELOCITY_X); -NODES[17124].Fix(VELOCITY_Y); -NODES[17124].Fix(VELOCITY_Z); -NODES[17125].Fix(VELOCITY_X); -NODES[17125].Fix(VELOCITY_Y); -NODES[17125].Fix(VELOCITY_Z); -NODES[17133].Fix(VELOCITY_X); -NODES[17133].Fix(VELOCITY_Y); -NODES[17133].Fix(VELOCITY_Z); -NODES[17142].Fix(VELOCITY_X); -NODES[17142].Fix(VELOCITY_Y); -NODES[17142].Fix(VELOCITY_Z); -NODES[17145].Fix(VELOCITY_X); -NODES[17145].Fix(VELOCITY_Y); -NODES[17145].Fix(VELOCITY_Z); -NODES[17152].Fix(VELOCITY_X); -NODES[17152].Fix(VELOCITY_Y); -NODES[17152].Fix(VELOCITY_Z); -NODES[17153].Fix(VELOCITY_X); -NODES[17153].Fix(VELOCITY_Y); -NODES[17153].Fix(VELOCITY_Z); -NODES[17158].Fix(VELOCITY_X); -NODES[17158].Fix(VELOCITY_Y); -NODES[17158].Fix(VELOCITY_Z); -NODES[17161].Fix(VELOCITY_X); -NODES[17161].Fix(VELOCITY_Y); -NODES[17161].Fix(VELOCITY_Z); -NODES[17167].Fix(VELOCITY_X); -NODES[17167].Fix(VELOCITY_Y); -NODES[17167].Fix(VELOCITY_Z); -NODES[17169].Fix(VELOCITY_X); -NODES[17169].Fix(VELOCITY_Y); -NODES[17169].Fix(VELOCITY_Z); -NODES[17190].Fix(VELOCITY_X); -NODES[17190].Fix(VELOCITY_Y); -NODES[17190].Fix(VELOCITY_Z); -NODES[17191].Fix(VELOCITY_X); -NODES[17191].Fix(VELOCITY_Y); -NODES[17191].Fix(VELOCITY_Z); -NODES[17193].Fix(VELOCITY_X); -NODES[17193].Fix(VELOCITY_Y); -NODES[17193].Fix(VELOCITY_Z); -NODES[17194].Fix(VELOCITY_X); -NODES[17194].Fix(VELOCITY_Y); -NODES[17194].Fix(VELOCITY_Z); -NODES[17196].Fix(VELOCITY_X); -NODES[17196].Fix(VELOCITY_Y); -NODES[17196].Fix(VELOCITY_Z); -NODES[17197].Fix(VELOCITY_X); -NODES[17197].Fix(VELOCITY_Y); -NODES[17197].Fix(VELOCITY_Z); -NODES[17200].Fix(VELOCITY_X); -NODES[17200].Fix(VELOCITY_Y); -NODES[17200].Fix(VELOCITY_Z); -NODES[17202].Fix(VELOCITY_X); -NODES[17202].Fix(VELOCITY_Y); -NODES[17202].Fix(VELOCITY_Z); -NODES[17209].Fix(VELOCITY_X); -NODES[17209].Fix(VELOCITY_Y); -NODES[17209].Fix(VELOCITY_Z); -NODES[17211].Fix(VELOCITY_X); -NODES[17211].Fix(VELOCITY_Y); -NODES[17211].Fix(VELOCITY_Z); -NODES[17233].Fix(VELOCITY_X); -NODES[17233].Fix(VELOCITY_Y); -NODES[17233].Fix(VELOCITY_Z); -NODES[17235].Fix(VELOCITY_X); -NODES[17235].Fix(VELOCITY_Y); -NODES[17235].Fix(VELOCITY_Z); -NODES[17238].Fix(VELOCITY_X); -NODES[17238].Fix(VELOCITY_Y); -NODES[17238].Fix(VELOCITY_Z); -NODES[17240].Fix(VELOCITY_X); -NODES[17240].Fix(VELOCITY_Y); -NODES[17240].Fix(VELOCITY_Z); -NODES[17245].Fix(VELOCITY_X); -NODES[17245].Fix(VELOCITY_Y); -NODES[17245].Fix(VELOCITY_Z); -NODES[17262].Fix(VELOCITY_X); -NODES[17262].Fix(VELOCITY_Y); -NODES[17262].Fix(VELOCITY_Z); -NODES[17266].Fix(VELOCITY_X); -NODES[17266].Fix(VELOCITY_Y); -NODES[17266].Fix(VELOCITY_Z); -NODES[17270].Fix(VELOCITY_X); -NODES[17270].Fix(VELOCITY_Y); -NODES[17270].Fix(VELOCITY_Z); -NODES[17272].Fix(VELOCITY_X); -NODES[17272].Fix(VELOCITY_Y); -NODES[17272].Fix(VELOCITY_Z); -NODES[17276].Fix(VELOCITY_X); -NODES[17276].Fix(VELOCITY_Y); -NODES[17276].Fix(VELOCITY_Z); -NODES[17278].Fix(VELOCITY_X); -NODES[17278].Fix(VELOCITY_Y); -NODES[17278].Fix(VELOCITY_Z); -NODES[17279].Fix(VELOCITY_X); -NODES[17279].Fix(VELOCITY_Y); -NODES[17279].Fix(VELOCITY_Z); -NODES[17284].Fix(VELOCITY_X); -NODES[17284].Fix(VELOCITY_Y); -NODES[17284].Fix(VELOCITY_Z); -NODES[17287].Fix(VELOCITY_X); -NODES[17287].Fix(VELOCITY_Y); -NODES[17287].Fix(VELOCITY_Z); -NODES[17295].Fix(VELOCITY_X); -NODES[17295].Fix(VELOCITY_Y); -NODES[17295].Fix(VELOCITY_Z); -NODES[17299].Fix(VELOCITY_X); -NODES[17299].Fix(VELOCITY_Y); -NODES[17299].Fix(VELOCITY_Z); -NODES[17300].Fix(VELOCITY_X); -NODES[17300].Fix(VELOCITY_Y); -NODES[17300].Fix(VELOCITY_Z); -NODES[17302].Fix(VELOCITY_X); -NODES[17302].Fix(VELOCITY_Y); -NODES[17302].Fix(VELOCITY_Z); -NODES[17327].Fix(VELOCITY_X); -NODES[17327].Fix(VELOCITY_Y); -NODES[17327].Fix(VELOCITY_Z); -NODES[17330].Fix(VELOCITY_X); -NODES[17330].Fix(VELOCITY_Y); -NODES[17330].Fix(VELOCITY_Z); -NODES[17347].Fix(VELOCITY_X); -NODES[17347].Fix(VELOCITY_Y); -NODES[17347].Fix(VELOCITY_Z); -NODES[17357].Fix(VELOCITY_X); -NODES[17357].Fix(VELOCITY_Y); -NODES[17357].Fix(VELOCITY_Z); -NODES[17359].Fix(VELOCITY_X); -NODES[17359].Fix(VELOCITY_Y); -NODES[17359].Fix(VELOCITY_Z); -NODES[17361].Fix(VELOCITY_X); -NODES[17361].Fix(VELOCITY_Y); -NODES[17361].Fix(VELOCITY_Z); -NODES[17365].Fix(VELOCITY_X); -NODES[17365].Fix(VELOCITY_Y); -NODES[17365].Fix(VELOCITY_Z); -NODES[17366].Fix(VELOCITY_X); -NODES[17366].Fix(VELOCITY_Y); -NODES[17366].Fix(VELOCITY_Z); -NODES[17368].Fix(VELOCITY_X); -NODES[17368].Fix(VELOCITY_Y); -NODES[17368].Fix(VELOCITY_Z); -NODES[17370].Fix(VELOCITY_X); -NODES[17370].Fix(VELOCITY_Y); -NODES[17370].Fix(VELOCITY_Z); -NODES[17371].Fix(VELOCITY_X); -NODES[17371].Fix(VELOCITY_Y); -NODES[17371].Fix(VELOCITY_Z); -NODES[17376].Fix(VELOCITY_X); -NODES[17376].Fix(VELOCITY_Y); -NODES[17376].Fix(VELOCITY_Z); -NODES[17382].Fix(VELOCITY_X); -NODES[17382].Fix(VELOCITY_Y); -NODES[17382].Fix(VELOCITY_Z); -NODES[17386].Fix(VELOCITY_X); -NODES[17386].Fix(VELOCITY_Y); -NODES[17386].Fix(VELOCITY_Z); -NODES[17390].Fix(VELOCITY_X); -NODES[17390].Fix(VELOCITY_Y); -NODES[17390].Fix(VELOCITY_Z); -NODES[17392].Fix(VELOCITY_X); -NODES[17392].Fix(VELOCITY_Y); -NODES[17392].Fix(VELOCITY_Z); -NODES[17395].Fix(VELOCITY_X); -NODES[17395].Fix(VELOCITY_Y); -NODES[17395].Fix(VELOCITY_Z); -NODES[17400].Fix(VELOCITY_X); -NODES[17400].Fix(VELOCITY_Y); -NODES[17400].Fix(VELOCITY_Z); -NODES[17403].Fix(VELOCITY_X); -NODES[17403].Fix(VELOCITY_Y); -NODES[17403].Fix(VELOCITY_Z); -NODES[17404].Fix(VELOCITY_X); -NODES[17404].Fix(VELOCITY_Y); -NODES[17404].Fix(VELOCITY_Z); -NODES[17411].Fix(VELOCITY_X); -NODES[17411].Fix(VELOCITY_Y); -NODES[17411].Fix(VELOCITY_Z); -NODES[17413].Fix(VELOCITY_X); -NODES[17413].Fix(VELOCITY_Y); -NODES[17413].Fix(VELOCITY_Z); -NODES[17418].Fix(VELOCITY_X); -NODES[17418].Fix(VELOCITY_Y); -NODES[17418].Fix(VELOCITY_Z); -NODES[17422].Fix(VELOCITY_X); -NODES[17422].Fix(VELOCITY_Y); -NODES[17422].Fix(VELOCITY_Z); -NODES[17427].Fix(VELOCITY_X); -NODES[17427].Fix(VELOCITY_Y); -NODES[17427].Fix(VELOCITY_Z); -NODES[17436].Fix(VELOCITY_X); -NODES[17436].Fix(VELOCITY_Y); -NODES[17436].Fix(VELOCITY_Z); -NODES[17440].Fix(VELOCITY_X); -NODES[17440].Fix(VELOCITY_Y); -NODES[17440].Fix(VELOCITY_Z); -NODES[17442].Fix(VELOCITY_X); -NODES[17442].Fix(VELOCITY_Y); -NODES[17442].Fix(VELOCITY_Z); -NODES[17453].Fix(VELOCITY_X); -NODES[17453].Fix(VELOCITY_Y); -NODES[17453].Fix(VELOCITY_Z); -NODES[17455].Fix(VELOCITY_X); -NODES[17455].Fix(VELOCITY_Y); -NODES[17455].Fix(VELOCITY_Z); -NODES[17459].Fix(VELOCITY_X); -NODES[17459].Fix(VELOCITY_Y); -NODES[17459].Fix(VELOCITY_Z); -NODES[17465].Fix(VELOCITY_X); -NODES[17465].Fix(VELOCITY_Y); -NODES[17465].Fix(VELOCITY_Z); -NODES[17466].Fix(VELOCITY_X); -NODES[17466].Fix(VELOCITY_Y); -NODES[17466].Fix(VELOCITY_Z); -NODES[17472].Fix(VELOCITY_X); -NODES[17472].Fix(VELOCITY_Y); -NODES[17472].Fix(VELOCITY_Z); -NODES[17479].Fix(VELOCITY_X); -NODES[17479].Fix(VELOCITY_Y); -NODES[17479].Fix(VELOCITY_Z); -NODES[17482].Fix(VELOCITY_X); -NODES[17482].Fix(VELOCITY_Y); -NODES[17482].Fix(VELOCITY_Z); -NODES[17486].Fix(VELOCITY_X); -NODES[17486].Fix(VELOCITY_Y); -NODES[17486].Fix(VELOCITY_Z); -NODES[17487].Fix(VELOCITY_X); -NODES[17487].Fix(VELOCITY_Y); -NODES[17487].Fix(VELOCITY_Z); -NODES[17496].Fix(VELOCITY_X); -NODES[17496].Fix(VELOCITY_Y); -NODES[17496].Fix(VELOCITY_Z); -NODES[17498].Fix(VELOCITY_X); -NODES[17498].Fix(VELOCITY_Y); -NODES[17498].Fix(VELOCITY_Z); -NODES[17502].Fix(VELOCITY_X); -NODES[17502].Fix(VELOCITY_Y); -NODES[17502].Fix(VELOCITY_Z); -NODES[17508].Fix(VELOCITY_X); -NODES[17508].Fix(VELOCITY_Y); -NODES[17508].Fix(VELOCITY_Z); -NODES[17516].Fix(VELOCITY_X); -NODES[17516].Fix(VELOCITY_Y); -NODES[17516].Fix(VELOCITY_Z); -NODES[17518].Fix(VELOCITY_X); -NODES[17518].Fix(VELOCITY_Y); -NODES[17518].Fix(VELOCITY_Z); -NODES[17519].Fix(VELOCITY_X); -NODES[17519].Fix(VELOCITY_Y); -NODES[17519].Fix(VELOCITY_Z); -NODES[17522].Fix(VELOCITY_X); -NODES[17522].Fix(VELOCITY_Y); -NODES[17522].Fix(VELOCITY_Z); -NODES[17525].Fix(VELOCITY_X); -NODES[17525].Fix(VELOCITY_Y); -NODES[17525].Fix(VELOCITY_Z); -NODES[17526].Fix(VELOCITY_X); -NODES[17526].Fix(VELOCITY_Y); -NODES[17526].Fix(VELOCITY_Z); -NODES[17531].Fix(VELOCITY_X); -NODES[17531].Fix(VELOCITY_Y); -NODES[17531].Fix(VELOCITY_Z); -NODES[17538].Fix(VELOCITY_X); -NODES[17538].Fix(VELOCITY_Y); -NODES[17538].Fix(VELOCITY_Z); -NODES[17541].Fix(VELOCITY_X); -NODES[17541].Fix(VELOCITY_Y); -NODES[17541].Fix(VELOCITY_Z); -NODES[17559].Fix(VELOCITY_X); -NODES[17559].Fix(VELOCITY_Y); -NODES[17559].Fix(VELOCITY_Z); -NODES[17561].Fix(VELOCITY_X); -NODES[17561].Fix(VELOCITY_Y); -NODES[17561].Fix(VELOCITY_Z); -NODES[17562].Fix(VELOCITY_X); -NODES[17562].Fix(VELOCITY_Y); -NODES[17562].Fix(VELOCITY_Z); -NODES[17566].Fix(VELOCITY_X); -NODES[17566].Fix(VELOCITY_Y); -NODES[17566].Fix(VELOCITY_Z); -NODES[17567].Fix(VELOCITY_X); -NODES[17567].Fix(VELOCITY_Y); -NODES[17567].Fix(VELOCITY_Z); -NODES[17577].Fix(VELOCITY_X); -NODES[17577].Fix(VELOCITY_Y); -NODES[17577].Fix(VELOCITY_Z); -NODES[17579].Fix(VELOCITY_X); -NODES[17579].Fix(VELOCITY_Y); -NODES[17579].Fix(VELOCITY_Z); -NODES[17583].Fix(VELOCITY_X); -NODES[17583].Fix(VELOCITY_Y); -NODES[17583].Fix(VELOCITY_Z); -NODES[17584].Fix(VELOCITY_X); -NODES[17584].Fix(VELOCITY_Y); -NODES[17584].Fix(VELOCITY_Z); -NODES[17585].Fix(VELOCITY_X); -NODES[17585].Fix(VELOCITY_Y); -NODES[17585].Fix(VELOCITY_Z); -NODES[17606].Fix(VELOCITY_X); -NODES[17606].Fix(VELOCITY_Y); -NODES[17606].Fix(VELOCITY_Z); -NODES[17611].Fix(VELOCITY_X); -NODES[17611].Fix(VELOCITY_Y); -NODES[17611].Fix(VELOCITY_Z); -NODES[17617].Fix(VELOCITY_X); -NODES[17617].Fix(VELOCITY_Y); -NODES[17617].Fix(VELOCITY_Z); -NODES[17621].Fix(VELOCITY_X); -NODES[17621].Fix(VELOCITY_Y); -NODES[17621].Fix(VELOCITY_Z); -NODES[17628].Fix(VELOCITY_X); -NODES[17628].Fix(VELOCITY_Y); -NODES[17628].Fix(VELOCITY_Z); -NODES[17630].Fix(VELOCITY_X); -NODES[17630].Fix(VELOCITY_Y); -NODES[17630].Fix(VELOCITY_Z); -NODES[17632].Fix(VELOCITY_X); -NODES[17632].Fix(VELOCITY_Y); -NODES[17632].Fix(VELOCITY_Z); -NODES[17639].Fix(VELOCITY_X); -NODES[17639].Fix(VELOCITY_Y); -NODES[17639].Fix(VELOCITY_Z); -NODES[17642].Fix(VELOCITY_X); -NODES[17642].Fix(VELOCITY_Y); -NODES[17642].Fix(VELOCITY_Z); -NODES[17651].Fix(VELOCITY_X); -NODES[17651].Fix(VELOCITY_Y); -NODES[17651].Fix(VELOCITY_Z); -NODES[17654].Fix(VELOCITY_X); -NODES[17654].Fix(VELOCITY_Y); -NODES[17654].Fix(VELOCITY_Z); -NODES[17655].Fix(VELOCITY_X); -NODES[17655].Fix(VELOCITY_Y); -NODES[17655].Fix(VELOCITY_Z); -NODES[17661].Fix(VELOCITY_X); -NODES[17661].Fix(VELOCITY_Y); -NODES[17661].Fix(VELOCITY_Z); -NODES[17665].Fix(VELOCITY_X); -NODES[17665].Fix(VELOCITY_Y); -NODES[17665].Fix(VELOCITY_Z); -NODES[17668].Fix(VELOCITY_X); -NODES[17668].Fix(VELOCITY_Y); -NODES[17668].Fix(VELOCITY_Z); -NODES[17669].Fix(VELOCITY_X); -NODES[17669].Fix(VELOCITY_Y); -NODES[17669].Fix(VELOCITY_Z); -NODES[17675].Fix(VELOCITY_X); -NODES[17675].Fix(VELOCITY_Y); -NODES[17675].Fix(VELOCITY_Z); -NODES[17680].Fix(VELOCITY_X); -NODES[17680].Fix(VELOCITY_Y); -NODES[17680].Fix(VELOCITY_Z); -NODES[17681].Fix(VELOCITY_X); -NODES[17681].Fix(VELOCITY_Y); -NODES[17681].Fix(VELOCITY_Z); -NODES[17684].Fix(VELOCITY_X); -NODES[17684].Fix(VELOCITY_Y); -NODES[17684].Fix(VELOCITY_Z); -NODES[17685].Fix(VELOCITY_X); -NODES[17685].Fix(VELOCITY_Y); -NODES[17685].Fix(VELOCITY_Z); -NODES[17686].Fix(VELOCITY_X); -NODES[17686].Fix(VELOCITY_Y); -NODES[17686].Fix(VELOCITY_Z); -NODES[17690].Fix(VELOCITY_X); -NODES[17690].Fix(VELOCITY_Y); -NODES[17690].Fix(VELOCITY_Z); -NODES[17695].Fix(VELOCITY_X); -NODES[17695].Fix(VELOCITY_Y); -NODES[17695].Fix(VELOCITY_Z); -NODES[17696].Fix(VELOCITY_X); -NODES[17696].Fix(VELOCITY_Y); -NODES[17696].Fix(VELOCITY_Z); -NODES[17698].Fix(VELOCITY_X); -NODES[17698].Fix(VELOCITY_Y); -NODES[17698].Fix(VELOCITY_Z); -NODES[17713].Fix(VELOCITY_X); -NODES[17713].Fix(VELOCITY_Y); -NODES[17713].Fix(VELOCITY_Z); -NODES[17717].Fix(VELOCITY_X); -NODES[17717].Fix(VELOCITY_Y); -NODES[17717].Fix(VELOCITY_Z); -NODES[17718].Fix(VELOCITY_X); -NODES[17718].Fix(VELOCITY_Y); -NODES[17718].Fix(VELOCITY_Z); -NODES[17723].Fix(VELOCITY_X); -NODES[17723].Fix(VELOCITY_Y); -NODES[17723].Fix(VELOCITY_Z); -NODES[17726].Fix(VELOCITY_X); -NODES[17726].Fix(VELOCITY_Y); -NODES[17726].Fix(VELOCITY_Z); -NODES[17729].Fix(VELOCITY_X); -NODES[17729].Fix(VELOCITY_Y); -NODES[17729].Fix(VELOCITY_Z); -NODES[17735].Fix(VELOCITY_X); -NODES[17735].Fix(VELOCITY_Y); -NODES[17735].Fix(VELOCITY_Z); -NODES[17736].Fix(VELOCITY_X); -NODES[17736].Fix(VELOCITY_Y); -NODES[17736].Fix(VELOCITY_Z); -NODES[17742].Fix(VELOCITY_X); -NODES[17742].Fix(VELOCITY_Y); -NODES[17742].Fix(VELOCITY_Z); -NODES[17745].Fix(VELOCITY_X); -NODES[17745].Fix(VELOCITY_Y); -NODES[17745].Fix(VELOCITY_Z); -NODES[17757].Fix(VELOCITY_X); -NODES[17757].Fix(VELOCITY_Y); -NODES[17757].Fix(VELOCITY_Z); -NODES[17761].Fix(VELOCITY_X); -NODES[17761].Fix(VELOCITY_Y); -NODES[17761].Fix(VELOCITY_Z); -NODES[17762].Fix(VELOCITY_X); -NODES[17762].Fix(VELOCITY_Y); -NODES[17762].Fix(VELOCITY_Z); -NODES[17763].Fix(VELOCITY_X); -NODES[17763].Fix(VELOCITY_Y); -NODES[17763].Fix(VELOCITY_Z); -NODES[17765].Fix(VELOCITY_X); -NODES[17765].Fix(VELOCITY_Y); -NODES[17765].Fix(VELOCITY_Z); -NODES[17766].Fix(VELOCITY_X); -NODES[17766].Fix(VELOCITY_Y); -NODES[17766].Fix(VELOCITY_Z); -NODES[17771].Fix(VELOCITY_X); -NODES[17771].Fix(VELOCITY_Y); -NODES[17771].Fix(VELOCITY_Z); -NODES[17774].Fix(VELOCITY_X); -NODES[17774].Fix(VELOCITY_Y); -NODES[17774].Fix(VELOCITY_Z); -NODES[17776].Fix(VELOCITY_X); -NODES[17776].Fix(VELOCITY_Y); -NODES[17776].Fix(VELOCITY_Z); -NODES[17781].Fix(VELOCITY_X); -NODES[17781].Fix(VELOCITY_Y); -NODES[17781].Fix(VELOCITY_Z); -NODES[17797].Fix(VELOCITY_X); -NODES[17797].Fix(VELOCITY_Y); -NODES[17797].Fix(VELOCITY_Z); -NODES[17807].Fix(VELOCITY_X); -NODES[17807].Fix(VELOCITY_Y); -NODES[17807].Fix(VELOCITY_Z); -NODES[17816].Fix(VELOCITY_X); -NODES[17816].Fix(VELOCITY_Y); -NODES[17816].Fix(VELOCITY_Z); -NODES[17817].Fix(VELOCITY_X); -NODES[17817].Fix(VELOCITY_Y); -NODES[17817].Fix(VELOCITY_Z); -NODES[17819].Fix(VELOCITY_X); -NODES[17819].Fix(VELOCITY_Y); -NODES[17819].Fix(VELOCITY_Z); -NODES[17820].Fix(VELOCITY_X); -NODES[17820].Fix(VELOCITY_Y); -NODES[17820].Fix(VELOCITY_Z); -NODES[17829].Fix(VELOCITY_X); -NODES[17829].Fix(VELOCITY_Y); -NODES[17829].Fix(VELOCITY_Z); -NODES[17831].Fix(VELOCITY_X); -NODES[17831].Fix(VELOCITY_Y); -NODES[17831].Fix(VELOCITY_Z); -NODES[17837].Fix(VELOCITY_X); -NODES[17837].Fix(VELOCITY_Y); -NODES[17837].Fix(VELOCITY_Z); -NODES[17846].Fix(VELOCITY_X); -NODES[17846].Fix(VELOCITY_Y); -NODES[17846].Fix(VELOCITY_Z); -NODES[17847].Fix(VELOCITY_X); -NODES[17847].Fix(VELOCITY_Y); -NODES[17847].Fix(VELOCITY_Z); -NODES[17849].Fix(VELOCITY_X); -NODES[17849].Fix(VELOCITY_Y); -NODES[17849].Fix(VELOCITY_Z); -NODES[17861].Fix(VELOCITY_X); -NODES[17861].Fix(VELOCITY_Y); -NODES[17861].Fix(VELOCITY_Z); -NODES[17862].Fix(VELOCITY_X); -NODES[17862].Fix(VELOCITY_Y); -NODES[17862].Fix(VELOCITY_Z); -NODES[17864].Fix(VELOCITY_X); -NODES[17864].Fix(VELOCITY_Y); -NODES[17864].Fix(VELOCITY_Z); -NODES[17866].Fix(VELOCITY_X); -NODES[17866].Fix(VELOCITY_Y); -NODES[17866].Fix(VELOCITY_Z); -NODES[17869].Fix(VELOCITY_X); -NODES[17869].Fix(VELOCITY_Y); -NODES[17869].Fix(VELOCITY_Z); -NODES[17870].Fix(VELOCITY_X); -NODES[17870].Fix(VELOCITY_Y); -NODES[17870].Fix(VELOCITY_Z); -NODES[17871].Fix(VELOCITY_X); -NODES[17871].Fix(VELOCITY_Y); -NODES[17871].Fix(VELOCITY_Z); -NODES[17878].Fix(VELOCITY_X); -NODES[17878].Fix(VELOCITY_Y); -NODES[17878].Fix(VELOCITY_Z); -NODES[17880].Fix(VELOCITY_X); -NODES[17880].Fix(VELOCITY_Y); -NODES[17880].Fix(VELOCITY_Z); -NODES[17881].Fix(VELOCITY_X); -NODES[17881].Fix(VELOCITY_Y); -NODES[17881].Fix(VELOCITY_Z); -NODES[17883].Fix(VELOCITY_X); -NODES[17883].Fix(VELOCITY_Y); -NODES[17883].Fix(VELOCITY_Z); -NODES[17886].Fix(VELOCITY_X); -NODES[17886].Fix(VELOCITY_Y); -NODES[17886].Fix(VELOCITY_Z); -NODES[17888].Fix(VELOCITY_X); -NODES[17888].Fix(VELOCITY_Y); -NODES[17888].Fix(VELOCITY_Z); -NODES[17893].Fix(VELOCITY_X); -NODES[17893].Fix(VELOCITY_Y); -NODES[17893].Fix(VELOCITY_Z); -NODES[17898].Fix(VELOCITY_X); -NODES[17898].Fix(VELOCITY_Y); -NODES[17898].Fix(VELOCITY_Z); -NODES[17906].Fix(VELOCITY_X); -NODES[17906].Fix(VELOCITY_Y); -NODES[17906].Fix(VELOCITY_Z); -NODES[17907].Fix(VELOCITY_X); -NODES[17907].Fix(VELOCITY_Y); -NODES[17907].Fix(VELOCITY_Z); -NODES[17910].Fix(VELOCITY_X); -NODES[17910].Fix(VELOCITY_Y); -NODES[17910].Fix(VELOCITY_Z); -NODES[17914].Fix(VELOCITY_X); -NODES[17914].Fix(VELOCITY_Y); -NODES[17914].Fix(VELOCITY_Z); -NODES[17915].Fix(VELOCITY_X); -NODES[17915].Fix(VELOCITY_Y); -NODES[17915].Fix(VELOCITY_Z); -NODES[17916].Fix(VELOCITY_X); -NODES[17916].Fix(VELOCITY_Y); -NODES[17916].Fix(VELOCITY_Z); -NODES[17918].Fix(VELOCITY_X); -NODES[17918].Fix(VELOCITY_Y); -NODES[17918].Fix(VELOCITY_Z); -NODES[17923].Fix(VELOCITY_X); -NODES[17923].Fix(VELOCITY_Y); -NODES[17923].Fix(VELOCITY_Z); -NODES[17926].Fix(VELOCITY_X); -NODES[17926].Fix(VELOCITY_Y); -NODES[17926].Fix(VELOCITY_Z); -NODES[17927].Fix(VELOCITY_X); -NODES[17927].Fix(VELOCITY_Y); -NODES[17927].Fix(VELOCITY_Z); -NODES[17928].Fix(VELOCITY_X); -NODES[17928].Fix(VELOCITY_Y); -NODES[17928].Fix(VELOCITY_Z); -NODES[17937].Fix(VELOCITY_X); -NODES[17937].Fix(VELOCITY_Y); -NODES[17937].Fix(VELOCITY_Z); -NODES[17941].Fix(VELOCITY_X); -NODES[17941].Fix(VELOCITY_Y); -NODES[17941].Fix(VELOCITY_Z); -NODES[17942].Fix(VELOCITY_X); -NODES[17942].Fix(VELOCITY_Y); -NODES[17942].Fix(VELOCITY_Z); -NODES[17953].Fix(VELOCITY_X); -NODES[17953].Fix(VELOCITY_Y); -NODES[17953].Fix(VELOCITY_Z); -NODES[17954].Fix(VELOCITY_X); -NODES[17954].Fix(VELOCITY_Y); -NODES[17954].Fix(VELOCITY_Z); -NODES[17962].Fix(VELOCITY_X); -NODES[17962].Fix(VELOCITY_Y); -NODES[17962].Fix(VELOCITY_Z); -NODES[17968].Fix(VELOCITY_X); -NODES[17968].Fix(VELOCITY_Y); -NODES[17968].Fix(VELOCITY_Z); -NODES[17973].Fix(VELOCITY_X); -NODES[17973].Fix(VELOCITY_Y); -NODES[17973].Fix(VELOCITY_Z); -NODES[17976].Fix(VELOCITY_X); -NODES[17976].Fix(VELOCITY_Y); -NODES[17976].Fix(VELOCITY_Z); -NODES[17984].Fix(VELOCITY_X); -NODES[17984].Fix(VELOCITY_Y); -NODES[17984].Fix(VELOCITY_Z); -NODES[17985].Fix(VELOCITY_X); -NODES[17985].Fix(VELOCITY_Y); -NODES[17985].Fix(VELOCITY_Z); -NODES[17988].Fix(VELOCITY_X); -NODES[17988].Fix(VELOCITY_Y); -NODES[17988].Fix(VELOCITY_Z); -NODES[17989].Fix(VELOCITY_X); -NODES[17989].Fix(VELOCITY_Y); -NODES[17989].Fix(VELOCITY_Z); -NODES[17990].Fix(VELOCITY_X); -NODES[17990].Fix(VELOCITY_Y); -NODES[17990].Fix(VELOCITY_Z); -NODES[17991].Fix(VELOCITY_X); -NODES[17991].Fix(VELOCITY_Y); -NODES[17991].Fix(VELOCITY_Z); -NODES[17997].Fix(VELOCITY_X); -NODES[17997].Fix(VELOCITY_Y); -NODES[17997].Fix(VELOCITY_Z); -NODES[18000].Fix(VELOCITY_X); -NODES[18000].Fix(VELOCITY_Y); -NODES[18000].Fix(VELOCITY_Z); -NODES[18002].Fix(VELOCITY_X); -NODES[18002].Fix(VELOCITY_Y); -NODES[18002].Fix(VELOCITY_Z); -NODES[18006].Fix(VELOCITY_X); -NODES[18006].Fix(VELOCITY_Y); -NODES[18006].Fix(VELOCITY_Z); -NODES[18027].Fix(VELOCITY_X); -NODES[18027].Fix(VELOCITY_Y); -NODES[18027].Fix(VELOCITY_Z); -NODES[18028].Fix(VELOCITY_X); -NODES[18028].Fix(VELOCITY_Y); -NODES[18028].Fix(VELOCITY_Z); -NODES[18030].Fix(VELOCITY_X); -NODES[18030].Fix(VELOCITY_Y); -NODES[18030].Fix(VELOCITY_Z); -NODES[18032].Fix(VELOCITY_X); -NODES[18032].Fix(VELOCITY_Y); -NODES[18032].Fix(VELOCITY_Z); -NODES[18033].Fix(VELOCITY_X); -NODES[18033].Fix(VELOCITY_Y); -NODES[18033].Fix(VELOCITY_Z); -NODES[18040].Fix(VELOCITY_X); -NODES[18040].Fix(VELOCITY_Y); -NODES[18040].Fix(VELOCITY_Z); -NODES[18043].Fix(VELOCITY_X); -NODES[18043].Fix(VELOCITY_Y); -NODES[18043].Fix(VELOCITY_Z); -NODES[18046].Fix(VELOCITY_X); -NODES[18046].Fix(VELOCITY_Y); -NODES[18046].Fix(VELOCITY_Z); -NODES[18052].Fix(VELOCITY_X); -NODES[18052].Fix(VELOCITY_Y); -NODES[18052].Fix(VELOCITY_Z); -NODES[18053].Fix(VELOCITY_X); -NODES[18053].Fix(VELOCITY_Y); -NODES[18053].Fix(VELOCITY_Z); -NODES[18059].Fix(VELOCITY_X); -NODES[18059].Fix(VELOCITY_Y); -NODES[18059].Fix(VELOCITY_Z); -NODES[18064].Fix(VELOCITY_X); -NODES[18064].Fix(VELOCITY_Y); -NODES[18064].Fix(VELOCITY_Z); -NODES[18066].Fix(VELOCITY_X); -NODES[18066].Fix(VELOCITY_Y); -NODES[18066].Fix(VELOCITY_Z); -NODES[18068].Fix(VELOCITY_X); -NODES[18068].Fix(VELOCITY_Y); -NODES[18068].Fix(VELOCITY_Z); -NODES[18070].Fix(VELOCITY_X); -NODES[18070].Fix(VELOCITY_Y); -NODES[18070].Fix(VELOCITY_Z); -NODES[18071].Fix(VELOCITY_X); -NODES[18071].Fix(VELOCITY_Y); -NODES[18071].Fix(VELOCITY_Z); -NODES[18073].Fix(VELOCITY_X); -NODES[18073].Fix(VELOCITY_Y); -NODES[18073].Fix(VELOCITY_Z); -NODES[18080].Fix(VELOCITY_X); -NODES[18080].Fix(VELOCITY_Y); -NODES[18080].Fix(VELOCITY_Z); -NODES[18083].Fix(VELOCITY_X); -NODES[18083].Fix(VELOCITY_Y); -NODES[18083].Fix(VELOCITY_Z); -NODES[18084].Fix(VELOCITY_X); -NODES[18084].Fix(VELOCITY_Y); -NODES[18084].Fix(VELOCITY_Z); -NODES[18085].Fix(VELOCITY_X); -NODES[18085].Fix(VELOCITY_Y); -NODES[18085].Fix(VELOCITY_Z); -NODES[18086].Fix(VELOCITY_X); -NODES[18086].Fix(VELOCITY_Y); -NODES[18086].Fix(VELOCITY_Z); -NODES[18089].Fix(VELOCITY_X); -NODES[18089].Fix(VELOCITY_Y); -NODES[18089].Fix(VELOCITY_Z); -NODES[18095].Fix(VELOCITY_X); -NODES[18095].Fix(VELOCITY_Y); -NODES[18095].Fix(VELOCITY_Z); -NODES[18105].Fix(VELOCITY_X); -NODES[18105].Fix(VELOCITY_Y); -NODES[18105].Fix(VELOCITY_Z); -NODES[18106].Fix(VELOCITY_X); -NODES[18106].Fix(VELOCITY_Y); -NODES[18106].Fix(VELOCITY_Z); -NODES[18113].Fix(VELOCITY_X); -NODES[18113].Fix(VELOCITY_Y); -NODES[18113].Fix(VELOCITY_Z); -NODES[18115].Fix(VELOCITY_X); -NODES[18115].Fix(VELOCITY_Y); -NODES[18115].Fix(VELOCITY_Z); -NODES[18116].Fix(VELOCITY_X); -NODES[18116].Fix(VELOCITY_Y); -NODES[18116].Fix(VELOCITY_Z); -NODES[18118].Fix(VELOCITY_X); -NODES[18118].Fix(VELOCITY_Y); -NODES[18118].Fix(VELOCITY_Z); -NODES[18119].Fix(VELOCITY_X); -NODES[18119].Fix(VELOCITY_Y); -NODES[18119].Fix(VELOCITY_Z); -NODES[18120].Fix(VELOCITY_X); -NODES[18120].Fix(VELOCITY_Y); -NODES[18120].Fix(VELOCITY_Z); -NODES[18121].Fix(VELOCITY_X); -NODES[18121].Fix(VELOCITY_Y); -NODES[18121].Fix(VELOCITY_Z); -NODES[18125].Fix(VELOCITY_X); -NODES[18125].Fix(VELOCITY_Y); -NODES[18125].Fix(VELOCITY_Z); -NODES[18126].Fix(VELOCITY_X); -NODES[18126].Fix(VELOCITY_Y); -NODES[18126].Fix(VELOCITY_Z); -NODES[18136].Fix(VELOCITY_X); -NODES[18136].Fix(VELOCITY_Y); -NODES[18136].Fix(VELOCITY_Z); -NODES[18141].Fix(VELOCITY_X); -NODES[18141].Fix(VELOCITY_Y); -NODES[18141].Fix(VELOCITY_Z); -NODES[18142].Fix(VELOCITY_X); -NODES[18142].Fix(VELOCITY_Y); -NODES[18142].Fix(VELOCITY_Z); -NODES[18145].Fix(VELOCITY_X); -NODES[18145].Fix(VELOCITY_Y); -NODES[18145].Fix(VELOCITY_Z); -NODES[18147].Fix(VELOCITY_X); -NODES[18147].Fix(VELOCITY_Y); -NODES[18147].Fix(VELOCITY_Z); -NODES[18149].Fix(VELOCITY_X); -NODES[18149].Fix(VELOCITY_Y); -NODES[18149].Fix(VELOCITY_Z); -NODES[18150].Fix(VELOCITY_X); -NODES[18150].Fix(VELOCITY_Y); -NODES[18150].Fix(VELOCITY_Z); -NODES[18162].Fix(VELOCITY_X); -NODES[18162].Fix(VELOCITY_Y); -NODES[18162].Fix(VELOCITY_Z); -NODES[18163].Fix(VELOCITY_X); -NODES[18163].Fix(VELOCITY_Y); -NODES[18163].Fix(VELOCITY_Z); -NODES[18164].Fix(VELOCITY_X); -NODES[18164].Fix(VELOCITY_Y); -NODES[18164].Fix(VELOCITY_Z); -NODES[18167].Fix(VELOCITY_X); -NODES[18167].Fix(VELOCITY_Y); -NODES[18167].Fix(VELOCITY_Z); -NODES[18168].Fix(VELOCITY_X); -NODES[18168].Fix(VELOCITY_Y); -NODES[18168].Fix(VELOCITY_Z); -NODES[18170].Fix(VELOCITY_X); -NODES[18170].Fix(VELOCITY_Y); -NODES[18170].Fix(VELOCITY_Z); -NODES[18175].Fix(VELOCITY_X); -NODES[18175].Fix(VELOCITY_Y); -NODES[18175].Fix(VELOCITY_Z); -NODES[18180].Fix(VELOCITY_X); -NODES[18180].Fix(VELOCITY_Y); -NODES[18180].Fix(VELOCITY_Z); -NODES[18181].Fix(VELOCITY_X); -NODES[18181].Fix(VELOCITY_Y); -NODES[18181].Fix(VELOCITY_Z); -NODES[18184].Fix(VELOCITY_X); -NODES[18184].Fix(VELOCITY_Y); -NODES[18184].Fix(VELOCITY_Z); -NODES[18186].Fix(VELOCITY_X); -NODES[18186].Fix(VELOCITY_Y); -NODES[18186].Fix(VELOCITY_Z); -NODES[18190].Fix(VELOCITY_X); -NODES[18190].Fix(VELOCITY_Y); -NODES[18190].Fix(VELOCITY_Z); -NODES[18193].Fix(VELOCITY_X); -NODES[18193].Fix(VELOCITY_Y); -NODES[18193].Fix(VELOCITY_Z); -NODES[18197].Fix(VELOCITY_X); -NODES[18197].Fix(VELOCITY_Y); -NODES[18197].Fix(VELOCITY_Z); -NODES[18199].Fix(VELOCITY_X); -NODES[18199].Fix(VELOCITY_Y); -NODES[18199].Fix(VELOCITY_Z); -NODES[18203].Fix(VELOCITY_X); -NODES[18203].Fix(VELOCITY_Y); -NODES[18203].Fix(VELOCITY_Z); -NODES[18209].Fix(VELOCITY_X); -NODES[18209].Fix(VELOCITY_Y); -NODES[18209].Fix(VELOCITY_Z); -NODES[18214].Fix(VELOCITY_X); -NODES[18214].Fix(VELOCITY_Y); -NODES[18214].Fix(VELOCITY_Z); -NODES[18217].Fix(VELOCITY_X); -NODES[18217].Fix(VELOCITY_Y); -NODES[18217].Fix(VELOCITY_Z); -NODES[18218].Fix(VELOCITY_X); -NODES[18218].Fix(VELOCITY_Y); -NODES[18218].Fix(VELOCITY_Z); -NODES[18221].Fix(VELOCITY_X); -NODES[18221].Fix(VELOCITY_Y); -NODES[18221].Fix(VELOCITY_Z); -NODES[18225].Fix(VELOCITY_X); -NODES[18225].Fix(VELOCITY_Y); -NODES[18225].Fix(VELOCITY_Z); -NODES[18227].Fix(VELOCITY_X); -NODES[18227].Fix(VELOCITY_Y); -NODES[18227].Fix(VELOCITY_Z); -NODES[18233].Fix(VELOCITY_X); -NODES[18233].Fix(VELOCITY_Y); -NODES[18233].Fix(VELOCITY_Z); -NODES[18236].Fix(VELOCITY_X); -NODES[18236].Fix(VELOCITY_Y); -NODES[18236].Fix(VELOCITY_Z); -NODES[18242].Fix(VELOCITY_X); -NODES[18242].Fix(VELOCITY_Y); -NODES[18242].Fix(VELOCITY_Z); -NODES[18245].Fix(VELOCITY_X); -NODES[18245].Fix(VELOCITY_Y); -NODES[18245].Fix(VELOCITY_Z); -NODES[18247].Fix(VELOCITY_X); -NODES[18247].Fix(VELOCITY_Y); -NODES[18247].Fix(VELOCITY_Z); -NODES[18251].Fix(VELOCITY_X); -NODES[18251].Fix(VELOCITY_Y); -NODES[18251].Fix(VELOCITY_Z); -NODES[18255].Fix(VELOCITY_X); -NODES[18255].Fix(VELOCITY_Y); -NODES[18255].Fix(VELOCITY_Z); -NODES[18256].Fix(VELOCITY_X); -NODES[18256].Fix(VELOCITY_Y); -NODES[18256].Fix(VELOCITY_Z); -NODES[18259].Fix(VELOCITY_X); -NODES[18259].Fix(VELOCITY_Y); -NODES[18259].Fix(VELOCITY_Z); -NODES[18260].Fix(VELOCITY_X); -NODES[18260].Fix(VELOCITY_Y); -NODES[18260].Fix(VELOCITY_Z); -NODES[18261].Fix(VELOCITY_X); -NODES[18261].Fix(VELOCITY_Y); -NODES[18261].Fix(VELOCITY_Z); -NODES[18265].Fix(VELOCITY_X); -NODES[18265].Fix(VELOCITY_Y); -NODES[18265].Fix(VELOCITY_Z); -NODES[18266].Fix(VELOCITY_X); -NODES[18266].Fix(VELOCITY_Y); -NODES[18266].Fix(VELOCITY_Z); -NODES[18272].Fix(VELOCITY_X); -NODES[18272].Fix(VELOCITY_Y); -NODES[18272].Fix(VELOCITY_Z); -NODES[18273].Fix(VELOCITY_X); -NODES[18273].Fix(VELOCITY_Y); -NODES[18273].Fix(VELOCITY_Z); -NODES[18274].Fix(VELOCITY_X); -NODES[18274].Fix(VELOCITY_Y); -NODES[18274].Fix(VELOCITY_Z); -NODES[18284].Fix(VELOCITY_X); -NODES[18284].Fix(VELOCITY_Y); -NODES[18284].Fix(VELOCITY_Z); -NODES[18285].Fix(VELOCITY_X); -NODES[18285].Fix(VELOCITY_Y); -NODES[18285].Fix(VELOCITY_Z); -NODES[18286].Fix(VELOCITY_X); -NODES[18286].Fix(VELOCITY_Y); -NODES[18286].Fix(VELOCITY_Z); -NODES[18291].Fix(VELOCITY_X); -NODES[18291].Fix(VELOCITY_Y); -NODES[18291].Fix(VELOCITY_Z); -NODES[18300].Fix(VELOCITY_X); -NODES[18300].Fix(VELOCITY_Y); -NODES[18300].Fix(VELOCITY_Z); -NODES[18301].Fix(VELOCITY_X); -NODES[18301].Fix(VELOCITY_Y); -NODES[18301].Fix(VELOCITY_Z); -NODES[18303].Fix(VELOCITY_X); -NODES[18303].Fix(VELOCITY_Y); -NODES[18303].Fix(VELOCITY_Z); -NODES[18304].Fix(VELOCITY_X); -NODES[18304].Fix(VELOCITY_Y); -NODES[18304].Fix(VELOCITY_Z); -NODES[18306].Fix(VELOCITY_X); -NODES[18306].Fix(VELOCITY_Y); -NODES[18306].Fix(VELOCITY_Z); -NODES[18312].Fix(VELOCITY_X); -NODES[18312].Fix(VELOCITY_Y); -NODES[18312].Fix(VELOCITY_Z); -NODES[18316].Fix(VELOCITY_X); -NODES[18316].Fix(VELOCITY_Y); -NODES[18316].Fix(VELOCITY_Z); -NODES[18317].Fix(VELOCITY_X); -NODES[18317].Fix(VELOCITY_Y); -NODES[18317].Fix(VELOCITY_Z); -NODES[18322].Fix(VELOCITY_X); -NODES[18322].Fix(VELOCITY_Y); -NODES[18322].Fix(VELOCITY_Z); -NODES[18323].Fix(VELOCITY_X); -NODES[18323].Fix(VELOCITY_Y); -NODES[18323].Fix(VELOCITY_Z); -NODES[18325].Fix(VELOCITY_X); -NODES[18325].Fix(VELOCITY_Y); -NODES[18325].Fix(VELOCITY_Z); -NODES[18331].Fix(VELOCITY_X); -NODES[18331].Fix(VELOCITY_Y); -NODES[18331].Fix(VELOCITY_Z); -NODES[18337].Fix(VELOCITY_X); -NODES[18337].Fix(VELOCITY_Y); -NODES[18337].Fix(VELOCITY_Z); -NODES[18338].Fix(VELOCITY_X); -NODES[18338].Fix(VELOCITY_Y); -NODES[18338].Fix(VELOCITY_Z); -NODES[18339].Fix(VELOCITY_X); -NODES[18339].Fix(VELOCITY_Y); -NODES[18339].Fix(VELOCITY_Z); -NODES[18340].Fix(VELOCITY_X); -NODES[18340].Fix(VELOCITY_Y); -NODES[18340].Fix(VELOCITY_Z); -NODES[18341].Fix(VELOCITY_X); -NODES[18341].Fix(VELOCITY_Y); -NODES[18341].Fix(VELOCITY_Z); -NODES[18342].Fix(VELOCITY_X); -NODES[18342].Fix(VELOCITY_Y); -NODES[18342].Fix(VELOCITY_Z); -NODES[18343].Fix(VELOCITY_X); -NODES[18343].Fix(VELOCITY_Y); -NODES[18343].Fix(VELOCITY_Z); -NODES[18351].Fix(VELOCITY_X); -NODES[18351].Fix(VELOCITY_Y); -NODES[18351].Fix(VELOCITY_Z); -NODES[18352].Fix(VELOCITY_X); -NODES[18352].Fix(VELOCITY_Y); -NODES[18352].Fix(VELOCITY_Z); -NODES[18353].Fix(VELOCITY_X); -NODES[18353].Fix(VELOCITY_Y); -NODES[18353].Fix(VELOCITY_Z); -NODES[18356].Fix(VELOCITY_X); -NODES[18356].Fix(VELOCITY_Y); -NODES[18356].Fix(VELOCITY_Z); -NODES[18358].Fix(VELOCITY_X); -NODES[18358].Fix(VELOCITY_Y); -NODES[18358].Fix(VELOCITY_Z); -NODES[18359].Fix(VELOCITY_X); -NODES[18359].Fix(VELOCITY_Y); -NODES[18359].Fix(VELOCITY_Z); -NODES[18360].Fix(VELOCITY_X); -NODES[18360].Fix(VELOCITY_Y); -NODES[18360].Fix(VELOCITY_Z); -NODES[18361].Fix(VELOCITY_X); -NODES[18361].Fix(VELOCITY_Y); -NODES[18361].Fix(VELOCITY_Z); -NODES[18365].Fix(VELOCITY_X); -NODES[18365].Fix(VELOCITY_Y); -NODES[18365].Fix(VELOCITY_Z); -NODES[18367].Fix(VELOCITY_X); -NODES[18367].Fix(VELOCITY_Y); -NODES[18367].Fix(VELOCITY_Z); -NODES[18369].Fix(VELOCITY_X); -NODES[18369].Fix(VELOCITY_Y); -NODES[18369].Fix(VELOCITY_Z); -NODES[18372].Fix(VELOCITY_X); -NODES[18372].Fix(VELOCITY_Y); -NODES[18372].Fix(VELOCITY_Z); -NODES[18373].Fix(VELOCITY_X); -NODES[18373].Fix(VELOCITY_Y); -NODES[18373].Fix(VELOCITY_Z); -NODES[18379].Fix(VELOCITY_X); -NODES[18379].Fix(VELOCITY_Y); -NODES[18379].Fix(VELOCITY_Z); -NODES[18381].Fix(VELOCITY_X); -NODES[18381].Fix(VELOCITY_Y); -NODES[18381].Fix(VELOCITY_Z); -NODES[18382].Fix(VELOCITY_X); -NODES[18382].Fix(VELOCITY_Y); -NODES[18382].Fix(VELOCITY_Z); -NODES[18384].Fix(VELOCITY_X); -NODES[18384].Fix(VELOCITY_Y); -NODES[18384].Fix(VELOCITY_Z); -NODES[18386].Fix(VELOCITY_X); -NODES[18386].Fix(VELOCITY_Y); -NODES[18386].Fix(VELOCITY_Z); -NODES[18390].Fix(VELOCITY_X); -NODES[18390].Fix(VELOCITY_Y); -NODES[18390].Fix(VELOCITY_Z); -NODES[18394].Fix(VELOCITY_X); -NODES[18394].Fix(VELOCITY_Y); -NODES[18394].Fix(VELOCITY_Z); -NODES[18400].Fix(VELOCITY_X); -NODES[18400].Fix(VELOCITY_Y); -NODES[18400].Fix(VELOCITY_Z); -NODES[18401].Fix(VELOCITY_X); -NODES[18401].Fix(VELOCITY_Y); -NODES[18401].Fix(VELOCITY_Z); -NODES[18402].Fix(VELOCITY_X); -NODES[18402].Fix(VELOCITY_Y); -NODES[18402].Fix(VELOCITY_Z); -NODES[18403].Fix(VELOCITY_X); -NODES[18403].Fix(VELOCITY_Y); -NODES[18403].Fix(VELOCITY_Z); -NODES[18404].Fix(VELOCITY_X); -NODES[18404].Fix(VELOCITY_Y); -NODES[18404].Fix(VELOCITY_Z); -NODES[18406].Fix(VELOCITY_X); -NODES[18406].Fix(VELOCITY_Y); -NODES[18406].Fix(VELOCITY_Z); -NODES[18408].Fix(VELOCITY_X); -NODES[18408].Fix(VELOCITY_Y); -NODES[18408].Fix(VELOCITY_Z); -NODES[18409].Fix(VELOCITY_X); -NODES[18409].Fix(VELOCITY_Y); -NODES[18409].Fix(VELOCITY_Z); -NODES[18410].Fix(VELOCITY_X); -NODES[18410].Fix(VELOCITY_Y); -NODES[18410].Fix(VELOCITY_Z); -NODES[18415].Fix(VELOCITY_X); -NODES[18415].Fix(VELOCITY_Y); -NODES[18415].Fix(VELOCITY_Z); -NODES[18422].Fix(VELOCITY_X); -NODES[18422].Fix(VELOCITY_Y); -NODES[18422].Fix(VELOCITY_Z); -NODES[18424].Fix(VELOCITY_X); -NODES[18424].Fix(VELOCITY_Y); -NODES[18424].Fix(VELOCITY_Z); -NODES[18425].Fix(VELOCITY_X); -NODES[18425].Fix(VELOCITY_Y); -NODES[18425].Fix(VELOCITY_Z); -NODES[18428].Fix(VELOCITY_X); -NODES[18428].Fix(VELOCITY_Y); -NODES[18428].Fix(VELOCITY_Z); -NODES[18433].Fix(VELOCITY_X); -NODES[18433].Fix(VELOCITY_Y); -NODES[18433].Fix(VELOCITY_Z); -NODES[18435].Fix(VELOCITY_X); -NODES[18435].Fix(VELOCITY_Y); -NODES[18435].Fix(VELOCITY_Z); -NODES[18437].Fix(VELOCITY_X); -NODES[18437].Fix(VELOCITY_Y); -NODES[18437].Fix(VELOCITY_Z); -NODES[18439].Fix(VELOCITY_X); -NODES[18439].Fix(VELOCITY_Y); -NODES[18439].Fix(VELOCITY_Z); -NODES[18441].Fix(VELOCITY_X); -NODES[18441].Fix(VELOCITY_Y); -NODES[18441].Fix(VELOCITY_Z); -NODES[18443].Fix(VELOCITY_X); -NODES[18443].Fix(VELOCITY_Y); -NODES[18443].Fix(VELOCITY_Z); -NODES[18446].Fix(VELOCITY_X); -NODES[18446].Fix(VELOCITY_Y); -NODES[18446].Fix(VELOCITY_Z); -NODES[18448].Fix(VELOCITY_X); -NODES[18448].Fix(VELOCITY_Y); -NODES[18448].Fix(VELOCITY_Z); -NODES[18449].Fix(VELOCITY_X); -NODES[18449].Fix(VELOCITY_Y); -NODES[18449].Fix(VELOCITY_Z); -NODES[18453].Fix(VELOCITY_X); -NODES[18453].Fix(VELOCITY_Y); -NODES[18453].Fix(VELOCITY_Z); -NODES[18455].Fix(VELOCITY_X); -NODES[18455].Fix(VELOCITY_Y); -NODES[18455].Fix(VELOCITY_Z); -NODES[18456].Fix(VELOCITY_X); -NODES[18456].Fix(VELOCITY_Y); -NODES[18456].Fix(VELOCITY_Z); -NODES[18457].Fix(VELOCITY_X); -NODES[18457].Fix(VELOCITY_Y); -NODES[18457].Fix(VELOCITY_Z); -NODES[18461].Fix(VELOCITY_X); -NODES[18461].Fix(VELOCITY_Y); -NODES[18461].Fix(VELOCITY_Z); -NODES[18465].Fix(VELOCITY_X); -NODES[18465].Fix(VELOCITY_Y); -NODES[18465].Fix(VELOCITY_Z); -NODES[18466].Fix(VELOCITY_X); -NODES[18466].Fix(VELOCITY_Y); -NODES[18466].Fix(VELOCITY_Z); -NODES[18467].Fix(VELOCITY_X); -NODES[18467].Fix(VELOCITY_Y); -NODES[18467].Fix(VELOCITY_Z); -NODES[18468].Fix(VELOCITY_X); -NODES[18468].Fix(VELOCITY_Y); -NODES[18468].Fix(VELOCITY_Z); -NODES[18469].Fix(VELOCITY_X); -NODES[18469].Fix(VELOCITY_Y); -NODES[18469].Fix(VELOCITY_Z); -NODES[18471].Fix(VELOCITY_X); -NODES[18471].Fix(VELOCITY_Y); -NODES[18471].Fix(VELOCITY_Z); -NODES[18476].Fix(VELOCITY_X); -NODES[18476].Fix(VELOCITY_Y); -NODES[18476].Fix(VELOCITY_Z); -NODES[18478].Fix(VELOCITY_X); -NODES[18478].Fix(VELOCITY_Y); -NODES[18478].Fix(VELOCITY_Z); -NODES[18479].Fix(VELOCITY_X); -NODES[18479].Fix(VELOCITY_Y); -NODES[18479].Fix(VELOCITY_Z); -NODES[18481].Fix(VELOCITY_X); -NODES[18481].Fix(VELOCITY_Y); -NODES[18481].Fix(VELOCITY_Z); -NODES[18482].Fix(VELOCITY_X); -NODES[18482].Fix(VELOCITY_Y); -NODES[18482].Fix(VELOCITY_Z); -NODES[18483].Fix(VELOCITY_X); -NODES[18483].Fix(VELOCITY_Y); -NODES[18483].Fix(VELOCITY_Z); -NODES[18490].Fix(VELOCITY_X); -NODES[18490].Fix(VELOCITY_Y); -NODES[18490].Fix(VELOCITY_Z); -NODES[18492].Fix(VELOCITY_X); -NODES[18492].Fix(VELOCITY_Y); -NODES[18492].Fix(VELOCITY_Z); -NODES[18494].Fix(VELOCITY_X); -NODES[18494].Fix(VELOCITY_Y); -NODES[18494].Fix(VELOCITY_Z); -NODES[18497].Fix(VELOCITY_X); -NODES[18497].Fix(VELOCITY_Y); -NODES[18497].Fix(VELOCITY_Z); -NODES[18498].Fix(VELOCITY_X); -NODES[18498].Fix(VELOCITY_Y); -NODES[18498].Fix(VELOCITY_Z); -NODES[18499].Fix(VELOCITY_X); -NODES[18499].Fix(VELOCITY_Y); -NODES[18499].Fix(VELOCITY_Z); -NODES[18500].Fix(VELOCITY_X); -NODES[18500].Fix(VELOCITY_Y); -NODES[18500].Fix(VELOCITY_Z); -NODES[18503].Fix(VELOCITY_X); -NODES[18503].Fix(VELOCITY_Y); -NODES[18503].Fix(VELOCITY_Z); -NODES[18505].Fix(VELOCITY_X); -NODES[18505].Fix(VELOCITY_Y); -NODES[18505].Fix(VELOCITY_Z); -NODES[18506].Fix(VELOCITY_X); -NODES[18506].Fix(VELOCITY_Y); -NODES[18506].Fix(VELOCITY_Z); -NODES[18508].Fix(VELOCITY_X); -NODES[18508].Fix(VELOCITY_Y); -NODES[18508].Fix(VELOCITY_Z); -NODES[18509].Fix(VELOCITY_X); -NODES[18509].Fix(VELOCITY_Y); -NODES[18509].Fix(VELOCITY_Z); -NODES[18512].Fix(VELOCITY_X); -NODES[18512].Fix(VELOCITY_Y); -NODES[18512].Fix(VELOCITY_Z); -NODES[18514].Fix(VELOCITY_X); -NODES[18514].Fix(VELOCITY_Y); -NODES[18514].Fix(VELOCITY_Z); -NODES[18515].Fix(VELOCITY_X); -NODES[18515].Fix(VELOCITY_Y); -NODES[18515].Fix(VELOCITY_Z); -NODES[18516].Fix(VELOCITY_X); -NODES[18516].Fix(VELOCITY_Y); -NODES[18516].Fix(VELOCITY_Z); -NODES[18517].Fix(VELOCITY_X); -NODES[18517].Fix(VELOCITY_Y); -NODES[18517].Fix(VELOCITY_Z); -NODES[18519].Fix(VELOCITY_X); -NODES[18519].Fix(VELOCITY_Y); -NODES[18519].Fix(VELOCITY_Z); -NODES[18521].Fix(VELOCITY_X); -NODES[18521].Fix(VELOCITY_Y); -NODES[18521].Fix(VELOCITY_Z); -NODES[18523].Fix(VELOCITY_X); -NODES[18523].Fix(VELOCITY_Y); -NODES[18523].Fix(VELOCITY_Z); -NODES[18527].Fix(VELOCITY_X); -NODES[18527].Fix(VELOCITY_Y); -NODES[18527].Fix(VELOCITY_Z); -NODES[18530].Fix(VELOCITY_X); -NODES[18530].Fix(VELOCITY_Y); -NODES[18530].Fix(VELOCITY_Z); -NODES[18531].Fix(VELOCITY_X); -NODES[18531].Fix(VELOCITY_Y); -NODES[18531].Fix(VELOCITY_Z); -NODES[18533].Fix(VELOCITY_X); -NODES[18533].Fix(VELOCITY_Y); -NODES[18533].Fix(VELOCITY_Z); -NODES[18536].Fix(VELOCITY_X); -NODES[18536].Fix(VELOCITY_Y); -NODES[18536].Fix(VELOCITY_Z); -NODES[18538].Fix(VELOCITY_X); -NODES[18538].Fix(VELOCITY_Y); -NODES[18538].Fix(VELOCITY_Z); -NODES[18539].Fix(VELOCITY_X); -NODES[18539].Fix(VELOCITY_Y); -NODES[18539].Fix(VELOCITY_Z); -NODES[18540].Fix(VELOCITY_X); -NODES[18540].Fix(VELOCITY_Y); -NODES[18540].Fix(VELOCITY_Z); -NODES[18541].Fix(VELOCITY_X); -NODES[18541].Fix(VELOCITY_Y); -NODES[18541].Fix(VELOCITY_Z); -NODES[18542].Fix(VELOCITY_X); -NODES[18542].Fix(VELOCITY_Y); -NODES[18542].Fix(VELOCITY_Z); -NODES[18543].Fix(VELOCITY_X); -NODES[18543].Fix(VELOCITY_Y); -NODES[18543].Fix(VELOCITY_Z); -NODES[18544].Fix(VELOCITY_X); -NODES[18544].Fix(VELOCITY_Y); -NODES[18544].Fix(VELOCITY_Z); -NODES[18545].Fix(VELOCITY_X); -NODES[18545].Fix(VELOCITY_Y); -NODES[18545].Fix(VELOCITY_Z); -NODES[18546].Fix(VELOCITY_X); -NODES[18546].Fix(VELOCITY_Y); -NODES[18546].Fix(VELOCITY_Z); -NODES[18554].Fix(VELOCITY_X); -NODES[18554].Fix(VELOCITY_Y); -NODES[18554].Fix(VELOCITY_Z); -NODES[18556].Fix(VELOCITY_X); -NODES[18556].Fix(VELOCITY_Y); -NODES[18556].Fix(VELOCITY_Z); -NODES[18557].Fix(VELOCITY_X); -NODES[18557].Fix(VELOCITY_Y); -NODES[18557].Fix(VELOCITY_Z); -NODES[18558].Fix(VELOCITY_X); -NODES[18558].Fix(VELOCITY_Y); -NODES[18558].Fix(VELOCITY_Z); -NODES[18559].Fix(VELOCITY_X); -NODES[18559].Fix(VELOCITY_Y); -NODES[18559].Fix(VELOCITY_Z); -NODES[18560].Fix(VELOCITY_X); -NODES[18560].Fix(VELOCITY_Y); -NODES[18560].Fix(VELOCITY_Z); -NODES[18562].Fix(VELOCITY_X); -NODES[18562].Fix(VELOCITY_Y); -NODES[18562].Fix(VELOCITY_Z); -NODES[18563].Fix(VELOCITY_X); -NODES[18563].Fix(VELOCITY_Y); -NODES[18563].Fix(VELOCITY_Z); -NODES[18564].Fix(VELOCITY_X); -NODES[18564].Fix(VELOCITY_Y); -NODES[18564].Fix(VELOCITY_Z); -NODES[18568].Fix(VELOCITY_X); -NODES[18568].Fix(VELOCITY_Y); -NODES[18568].Fix(VELOCITY_Z); -NODES[18569].Fix(VELOCITY_X); -NODES[18569].Fix(VELOCITY_Y); -NODES[18569].Fix(VELOCITY_Z); -NODES[18570].Fix(VELOCITY_X); -NODES[18570].Fix(VELOCITY_Y); -NODES[18570].Fix(VELOCITY_Z); -NODES[18573].Fix(VELOCITY_X); -NODES[18573].Fix(VELOCITY_Y); -NODES[18573].Fix(VELOCITY_Z); -NODES[18575].Fix(VELOCITY_X); -NODES[18575].Fix(VELOCITY_Y); -NODES[18575].Fix(VELOCITY_Z); -NODES[18576].Fix(VELOCITY_X); -NODES[18576].Fix(VELOCITY_Y); -NODES[18576].Fix(VELOCITY_Z); -NODES[18577].Fix(VELOCITY_X); -NODES[18577].Fix(VELOCITY_Y); -NODES[18577].Fix(VELOCITY_Z); -NODES[18579].Fix(VELOCITY_X); -NODES[18579].Fix(VELOCITY_Y); -NODES[18579].Fix(VELOCITY_Z); -NODES[18580].Fix(VELOCITY_X); -NODES[18580].Fix(VELOCITY_Y); -NODES[18580].Fix(VELOCITY_Z); -NODES[18581].Fix(VELOCITY_X); -NODES[18581].Fix(VELOCITY_Y); -NODES[18581].Fix(VELOCITY_Z); -NODES[18582].Fix(VELOCITY_X); -NODES[18582].Fix(VELOCITY_Y); -NODES[18582].Fix(VELOCITY_Z); -NODES[18585].Fix(VELOCITY_X); -NODES[18585].Fix(VELOCITY_Y); -NODES[18585].Fix(VELOCITY_Z); -NODES[18589].Fix(VELOCITY_X); -NODES[18589].Fix(VELOCITY_Y); -NODES[18589].Fix(VELOCITY_Z); -NODES[18590].Fix(VELOCITY_X); -NODES[18590].Fix(VELOCITY_Y); -NODES[18590].Fix(VELOCITY_Z); -NODES[18591].Fix(VELOCITY_X); -NODES[18591].Fix(VELOCITY_Y); -NODES[18591].Fix(VELOCITY_Z); -NODES[18592].Fix(VELOCITY_X); -NODES[18592].Fix(VELOCITY_Y); -NODES[18592].Fix(VELOCITY_Z); -NODES[18593].Fix(VELOCITY_X); -NODES[18593].Fix(VELOCITY_Y); -NODES[18593].Fix(VELOCITY_Z); -NODES[18594].Fix(VELOCITY_X); -NODES[18594].Fix(VELOCITY_Y); -NODES[18594].Fix(VELOCITY_Z); -NODES[18595].Fix(VELOCITY_X); -NODES[18595].Fix(VELOCITY_Y); -NODES[18595].Fix(VELOCITY_Z); -NODES[18597].Fix(VELOCITY_X); -NODES[18597].Fix(VELOCITY_Y); -NODES[18597].Fix(VELOCITY_Z); -NODES[18601].Fix(VELOCITY_X); -NODES[18601].Fix(VELOCITY_Y); -NODES[18601].Fix(VELOCITY_Z); -NODES[18604].Fix(VELOCITY_X); -NODES[18604].Fix(VELOCITY_Y); -NODES[18604].Fix(VELOCITY_Z); -NODES[18605].Fix(VELOCITY_X); -NODES[18605].Fix(VELOCITY_Y); -NODES[18605].Fix(VELOCITY_Z); -NODES[18609].Fix(VELOCITY_X); -NODES[18609].Fix(VELOCITY_Y); -NODES[18609].Fix(VELOCITY_Z); -NODES[18610].Fix(VELOCITY_X); -NODES[18610].Fix(VELOCITY_Y); -NODES[18610].Fix(VELOCITY_Z); -NODES[18611].Fix(VELOCITY_X); -NODES[18611].Fix(VELOCITY_Y); -NODES[18611].Fix(VELOCITY_Z); -NODES[18612].Fix(VELOCITY_X); -NODES[18612].Fix(VELOCITY_Y); -NODES[18612].Fix(VELOCITY_Z); -NODES[18613].Fix(VELOCITY_X); -NODES[18613].Fix(VELOCITY_Y); -NODES[18613].Fix(VELOCITY_Z); -NODES[18616].Fix(VELOCITY_X); -NODES[18616].Fix(VELOCITY_Y); -NODES[18616].Fix(VELOCITY_Z); -NODES[18618].Fix(VELOCITY_X); -NODES[18618].Fix(VELOCITY_Y); -NODES[18618].Fix(VELOCITY_Z); -NODES[18619].Fix(VELOCITY_X); -NODES[18619].Fix(VELOCITY_Y); -NODES[18619].Fix(VELOCITY_Z); -NODES[18621].Fix(VELOCITY_X); -NODES[18621].Fix(VELOCITY_Y); -NODES[18621].Fix(VELOCITY_Z); -NODES[18622].Fix(VELOCITY_X); -NODES[18622].Fix(VELOCITY_Y); -NODES[18622].Fix(VELOCITY_Z); -NODES[18623].Fix(VELOCITY_X); -NODES[18623].Fix(VELOCITY_Y); -NODES[18623].Fix(VELOCITY_Z); -NODES[18624].Fix(VELOCITY_X); -NODES[18624].Fix(VELOCITY_Y); -NODES[18624].Fix(VELOCITY_Z); -NODES[18626].Fix(VELOCITY_X); -NODES[18626].Fix(VELOCITY_Y); -NODES[18626].Fix(VELOCITY_Z); -NODES[18629].Fix(VELOCITY_X); -NODES[18629].Fix(VELOCITY_Y); -NODES[18629].Fix(VELOCITY_Z); -NODES[18630].Fix(VELOCITY_X); -NODES[18630].Fix(VELOCITY_Y); -NODES[18630].Fix(VELOCITY_Z); -NODES[18632].Fix(VELOCITY_X); -NODES[18632].Fix(VELOCITY_Y); -NODES[18632].Fix(VELOCITY_Z); -NODES[18633].Fix(VELOCITY_X); -NODES[18633].Fix(VELOCITY_Y); -NODES[18633].Fix(VELOCITY_Z); -NODES[18634].Fix(VELOCITY_X); -NODES[18634].Fix(VELOCITY_Y); -NODES[18634].Fix(VELOCITY_Z); -NODES[18635].Fix(VELOCITY_X); -NODES[18635].Fix(VELOCITY_Y); -NODES[18635].Fix(VELOCITY_Z); -NODES[18636].Fix(VELOCITY_X); -NODES[18636].Fix(VELOCITY_Y); -NODES[18636].Fix(VELOCITY_Z); -NODES[18639].Fix(VELOCITY_X); -NODES[18639].Fix(VELOCITY_Y); -NODES[18639].Fix(VELOCITY_Z); -NODES[18641].Fix(VELOCITY_X); -NODES[18641].Fix(VELOCITY_Y); -NODES[18641].Fix(VELOCITY_Z); -NODES[18642].Fix(VELOCITY_X); -NODES[18642].Fix(VELOCITY_Y); -NODES[18642].Fix(VELOCITY_Z); -NODES[18644].Fix(VELOCITY_X); -NODES[18644].Fix(VELOCITY_Y); -NODES[18644].Fix(VELOCITY_Z); -NODES[18645].Fix(VELOCITY_X); -NODES[18645].Fix(VELOCITY_Y); -NODES[18645].Fix(VELOCITY_Z); -NODES[18646].Fix(VELOCITY_X); -NODES[18646].Fix(VELOCITY_Y); -NODES[18646].Fix(VELOCITY_Z); -NODES[18647].Fix(VELOCITY_X); -NODES[18647].Fix(VELOCITY_Y); -NODES[18647].Fix(VELOCITY_Z); -NODES[18654].Fix(VELOCITY_X); -NODES[18654].Fix(VELOCITY_Y); -NODES[18654].Fix(VELOCITY_Z); -NODES[18657].Fix(VELOCITY_X); -NODES[18657].Fix(VELOCITY_Y); -NODES[18657].Fix(VELOCITY_Z); -NODES[18658].Fix(VELOCITY_X); -NODES[18658].Fix(VELOCITY_Y); -NODES[18658].Fix(VELOCITY_Z); -NODES[18659].Fix(VELOCITY_X); -NODES[18659].Fix(VELOCITY_Y); -NODES[18659].Fix(VELOCITY_Z); -NODES[18660].Fix(VELOCITY_X); -NODES[18660].Fix(VELOCITY_Y); -NODES[18660].Fix(VELOCITY_Z); -NODES[18661].Fix(VELOCITY_X); -NODES[18661].Fix(VELOCITY_Y); -NODES[18661].Fix(VELOCITY_Z); -NODES[18662].Fix(VELOCITY_X); -NODES[18662].Fix(VELOCITY_Y); -NODES[18662].Fix(VELOCITY_Z); -NODES[18663].Fix(VELOCITY_X); -NODES[18663].Fix(VELOCITY_Y); -NODES[18663].Fix(VELOCITY_Z); -NODES[18664].Fix(VELOCITY_X); -NODES[18664].Fix(VELOCITY_Y); -NODES[18664].Fix(VELOCITY_Z); -NODES[18666].Fix(VELOCITY_X); -NODES[18666].Fix(VELOCITY_Y); -NODES[18666].Fix(VELOCITY_Z); -NODES[18667].Fix(VELOCITY_X); -NODES[18667].Fix(VELOCITY_Y); -NODES[18667].Fix(VELOCITY_Z); -NODES[18668].Fix(VELOCITY_X); -NODES[18668].Fix(VELOCITY_Y); -NODES[18668].Fix(VELOCITY_Z); -NODES[18669].Fix(VELOCITY_X); -NODES[18669].Fix(VELOCITY_Y); -NODES[18669].Fix(VELOCITY_Z); -NODES[18672].Fix(VELOCITY_X); -NODES[18672].Fix(VELOCITY_Y); -NODES[18672].Fix(VELOCITY_Z); -NODES[18673].Fix(VELOCITY_X); -NODES[18673].Fix(VELOCITY_Y); -NODES[18673].Fix(VELOCITY_Z); -NODES[18674].Fix(VELOCITY_X); -NODES[18674].Fix(VELOCITY_Y); -NODES[18674].Fix(VELOCITY_Z); -NODES[18676].Fix(VELOCITY_X); -NODES[18676].Fix(VELOCITY_Y); -NODES[18676].Fix(VELOCITY_Z); -NODES[18677].Fix(VELOCITY_X); -NODES[18677].Fix(VELOCITY_Y); -NODES[18677].Fix(VELOCITY_Z); -NODES[18680].Fix(VELOCITY_X); -NODES[18680].Fix(VELOCITY_Y); -NODES[18680].Fix(VELOCITY_Z); -NODES[18681].Fix(VELOCITY_X); -NODES[18681].Fix(VELOCITY_Y); -NODES[18681].Fix(VELOCITY_Z); -NODES[18682].Fix(VELOCITY_X); -NODES[18682].Fix(VELOCITY_Y); -NODES[18682].Fix(VELOCITY_Z); -NODES[18683].Fix(VELOCITY_X); -NODES[18683].Fix(VELOCITY_Y); -NODES[18683].Fix(VELOCITY_Z); -NODES[18684].Fix(VELOCITY_X); -NODES[18684].Fix(VELOCITY_Y); -NODES[18684].Fix(VELOCITY_Z); -NODES[18686].Fix(VELOCITY_X); -NODES[18686].Fix(VELOCITY_Y); -NODES[18686].Fix(VELOCITY_Z); -NODES[18687].Fix(VELOCITY_X); -NODES[18687].Fix(VELOCITY_Y); -NODES[18687].Fix(VELOCITY_Z); -NODES[18688].Fix(VELOCITY_X); -NODES[18688].Fix(VELOCITY_Y); -NODES[18688].Fix(VELOCITY_Z); -NODES[18689].Fix(VELOCITY_X); -NODES[18689].Fix(VELOCITY_Y); -NODES[18689].Fix(VELOCITY_Z); -NODES[18690].Fix(VELOCITY_X); -NODES[18690].Fix(VELOCITY_Y); -NODES[18690].Fix(VELOCITY_Z); -NODES[18692].Fix(VELOCITY_X); -NODES[18692].Fix(VELOCITY_Y); -NODES[18692].Fix(VELOCITY_Z); -NODES[18693].Fix(VELOCITY_X); -NODES[18693].Fix(VELOCITY_Y); -NODES[18693].Fix(VELOCITY_Z); -NODES[18694].Fix(VELOCITY_X); -NODES[18694].Fix(VELOCITY_Y); -NODES[18694].Fix(VELOCITY_Z); -NODES[18695].Fix(VELOCITY_X); -NODES[18695].Fix(VELOCITY_Y); -NODES[18695].Fix(VELOCITY_Z); -NODES[18696].Fix(VELOCITY_X); -NODES[18696].Fix(VELOCITY_Y); -NODES[18696].Fix(VELOCITY_Z); -NODES[18697].Fix(VELOCITY_X); -NODES[18697].Fix(VELOCITY_Y); -NODES[18697].Fix(VELOCITY_Z); -NODES[18698].Fix(VELOCITY_X); -NODES[18698].Fix(VELOCITY_Y); -NODES[18698].Fix(VELOCITY_Z); -NODES[18699].Fix(VELOCITY_X); -NODES[18699].Fix(VELOCITY_Y); -NODES[18699].Fix(VELOCITY_Z); diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.dat b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.dat deleted file mode 100644 index cd1cd61ef19d..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.dat +++ /dev/null @@ -1 +0,0 @@ -Write comments and documentation diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.elem b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.elem deleted file mode 100644 index dde62119b855..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.elem +++ /dev/null @@ -1,78497 +0,0 @@ -// Reading Elements - -ElementsGroup = fluid_group; - -ELEMENTS[1] = Fluid3D([4677,4938,4389,4738],0); -ELEMENTS[2] = Fluid3D([4938,4389,4738,4799],0); -ELEMENTS[3] = Fluid3D([2752,2708,2464,2637],0); -ELEMENTS[4] = Fluid3D([2464,2752,2637,2602],0); -ELEMENTS[5] = Fluid3D([2752,2708,2637,3067],0); -ELEMENTS[6] = Fluid3D([6145,5548,5832,5569],0); -ELEMENTS[7] = Fluid3D([5832,6145,5569,6385],0); -ELEMENTS[8] = Fluid3D([13501,12765,13681,13316],0); -ELEMENTS[9] = Fluid3D([13501,12765,13316,12679],0); -ELEMENTS[10] = Fluid3D([13681,13501,13316,14438],0); -ELEMENTS[11] = Fluid3D([8594,8048,9067,8727],0); -ELEMENTS[12] = Fluid3D([8594,8048,8727,7661],0); -ELEMENTS[13] = Fluid3D([9067,8594,8727,9638],0); -ELEMENTS[14] = Fluid3D([4677,4938,4738,5172],0); -ELEMENTS[15] = Fluid3D([4677,4938,5172,5578],0); -ELEMENTS[16] = Fluid3D([5548,5832,5569,5222],0); -ELEMENTS[17] = Fluid3D([4938,4738,5172,5231],0); -ELEMENTS[18] = Fluid3D([4938,4738,5231,4799],0); -ELEMENTS[19] = Fluid3D([5426,4799,4938,5231],0); -ELEMENTS[20] = Fluid3D([4938,5172,5578,5231],0); -ELEMENTS[21] = Fluid3D([4389,4677,4738,4091],0); -ELEMENTS[22] = Fluid3D([4938,5426,5231,5578],0); -ELEMENTS[23] = Fluid3D([15938,16451,16357,16064],0); -ELEMENTS[24] = Fluid3D([16451,16357,16064,16828],0); -ELEMENTS[25] = Fluid3D([16357,15938,16064,15793],0); -ELEMENTS[26] = Fluid3D([16064,16357,15793,16222],0); -ELEMENTS[27] = Fluid3D([16064,16357,16222,16828],0); -ELEMENTS[28] = Fluid3D([4738,4677,5172,4737],0); -ELEMENTS[29] = Fluid3D([4677,5172,4737,5133],0); -ELEMENTS[30] = Fluid3D([4738,4677,4737,4091],0); -ELEMENTS[31] = Fluid3D([5172,4738,4737,5053],0); -ELEMENTS[32] = Fluid3D([4737,5172,5053,5385],0); -ELEMENTS[33] = Fluid3D([16357,15938,15793,15966],0); -ELEMENTS[34] = Fluid3D([15793,16357,15966,16222],0); -ELEMENTS[35] = Fluid3D([4738,5172,5231,5053],0); -ELEMENTS[36] = Fluid3D([15793,16064,16222,15640],0); -ELEMENTS[37] = Fluid3D([16064,16222,15640,16184],0); -ELEMENTS[38] = Fluid3D([16064,16222,16184,16592],0); -ELEMENTS[39] = Fluid3D([16064,16222,16592,16828],0); -ELEMENTS[40] = Fluid3D([5172,5053,5385,5715],0); -ELEMENTS[41] = Fluid3D([16222,15640,16184,16009],0); -ELEMENTS[42] = Fluid3D([5385,5172,5715,5740],0); -ELEMENTS[43] = Fluid3D([16828,16529,16357,16222],0); -ELEMENTS[44] = Fluid3D([16529,16357,16222,15966],0); -ELEMENTS[45] = Fluid3D([16222,16184,16592,16594],0); -ELEMENTS[46] = Fluid3D([16592,16222,16594,16828],0); -ELEMENTS[47] = Fluid3D([16222,16184,16594,16009],0); -ELEMENTS[48] = Fluid3D([16184,16592,16594,16702],0); -ELEMENTS[49] = Fluid3D([16594,16184,16702,16403],0); -ELEMENTS[50] = Fluid3D([16594,16184,16403,16009],0); -ELEMENTS[51] = Fluid3D([16184,16592,16702,16400],0); -ELEMENTS[52] = Fluid3D([16592,16702,16400,16922],0); -ELEMENTS[53] = Fluid3D([16592,16702,16922,17005],0); -ELEMENTS[54] = Fluid3D([16592,16702,17005,16594],0); -ELEMENTS[55] = Fluid3D([16922,16592,17005,16828],0); -ELEMENTS[56] = Fluid3D([16592,17005,16828,16594],0); -ELEMENTS[57] = Fluid3D([16184,16592,16400,16064],0); -ELEMENTS[58] = Fluid3D([16222,15640,16009,15745],0); -ELEMENTS[59] = Fluid3D([16222,15640,15745,15793],0); -ELEMENTS[60] = Fluid3D([16009,16222,15745,16304],0); -ELEMENTS[61] = Fluid3D([16222,15745,16304,16529],0); -ELEMENTS[62] = Fluid3D([15640,16009,15745,15251],0); -ELEMENTS[63] = Fluid3D([15640,16009,15251,15631],0); -ELEMENTS[64] = Fluid3D([15640,16009,15631,16184],0); -ELEMENTS[65] = Fluid3D([15251,15640,15631,15055],0); -ELEMENTS[66] = Fluid3D([15251,15640,15055,15181],0); -ELEMENTS[67] = Fluid3D([15251,15640,15181,15745],0); -ELEMENTS[68] = Fluid3D([16009,15745,15251,15758],0); -ELEMENTS[69] = Fluid3D([15745,15251,15758,15210],0); -ELEMENTS[70] = Fluid3D([15745,15251,15210,15181],0); -ELEMENTS[71] = Fluid3D([16009,15745,15758,16304],0); -ELEMENTS[72] = Fluid3D([15631,15251,15055,15099],0); -ELEMENTS[73] = Fluid3D([15251,15055,15099,14569],0); -ELEMENTS[74] = Fluid3D([15251,15055,14569,15181],0); -ELEMENTS[75] = Fluid3D([15631,15251,15099,15628],0); -ELEMENTS[76] = Fluid3D([15631,15251,15628,16009],0); -ELEMENTS[77] = Fluid3D([15055,15631,15099,15254],0); -ELEMENTS[78] = Fluid3D([15055,15631,15254,15548],0); -ELEMENTS[79] = Fluid3D([15055,15631,15548,15640],0); -ELEMENTS[80] = Fluid3D([15099,15631,15628,15507],0); -ELEMENTS[81] = Fluid3D([15631,15628,15507,16128],0); -ELEMENTS[82] = Fluid3D([15631,15099,15254,15507],0); -ELEMENTS[83] = Fluid3D([15628,15507,16128,15859],0); -ELEMENTS[84] = Fluid3D([15628,15507,15859,15204],0); -ELEMENTS[85] = Fluid3D([15628,15507,15204,15099],0); -ELEMENTS[86] = Fluid3D([16128,15628,15859,16329],0); -ELEMENTS[87] = Fluid3D([15631,15628,16128,16009],0); -ELEMENTS[88] = Fluid3D([15507,16128,15859,16034],0); -ELEMENTS[89] = Fluid3D([16128,15859,16034,16478],0); -ELEMENTS[90] = Fluid3D([15507,16128,16034,15910],0); -ELEMENTS[91] = Fluid3D([16034,15507,15910,15537],0); -ELEMENTS[92] = Fluid3D([16034,15507,15537,15316],0); -ELEMENTS[93] = Fluid3D([16034,15507,15316,15859],0); -ELEMENTS[94] = Fluid3D([15507,16128,15910,15631],0); -ELEMENTS[95] = Fluid3D([16128,16034,15910,16457],0); -ELEMENTS[96] = Fluid3D([16034,15910,16457,16195],0); -ELEMENTS[97] = Fluid3D([16128,16034,16457,16478],0); -ELEMENTS[98] = Fluid3D([16457,16034,16195,16651],0); -ELEMENTS[99] = Fluid3D([16034,15910,16195,15537],0); -ELEMENTS[100] = Fluid3D([15910,16128,16457,16403],0); -ELEMENTS[101] = Fluid3D([16128,16457,16403,16478],0); -ELEMENTS[102] = Fluid3D([15910,16128,16403,15631],0); -ELEMENTS[103] = Fluid3D([16128,16403,15631,16009],0); -ELEMENTS[104] = Fluid3D([16128,16403,16009,16399],0); -ELEMENTS[105] = Fluid3D([16128,16403,16399,16478],0); -ELEMENTS[106] = Fluid3D([15758,15745,15210,15795],0); -ELEMENTS[107] = Fluid3D([15758,15745,15795,16304],0); -ELEMENTS[108] = Fluid3D([15745,15210,15795,15417],0); -ELEMENTS[109] = Fluid3D([15745,15210,15417,15181],0); -ELEMENTS[110] = Fluid3D([15210,15795,15417,15200],0); -ELEMENTS[111] = Fluid3D([15417,15210,15200,14709],0); -ELEMENTS[112] = Fluid3D([15210,15758,15795,15435],0); -ELEMENTS[113] = Fluid3D([15210,15795,15200,15435],0); -ELEMENTS[114] = Fluid3D([15210,15758,15435,15045],0); -ELEMENTS[115] = Fluid3D([15758,15435,15045,15685],0); -ELEMENTS[116] = Fluid3D([15758,15435,15685,16156],0); -ELEMENTS[117] = Fluid3D([15685,15758,16156,16329],0); -ELEMENTS[118] = Fluid3D([15210,15758,15045,15251],0); -ELEMENTS[119] = Fluid3D([15417,15210,14709,15181],0); -ELEMENTS[120] = Fluid3D([15758,15795,15435,16156],0); -ELEMENTS[121] = Fluid3D([15795,15417,15200,15920],0); -ELEMENTS[122] = Fluid3D([16702,16184,16400,16281],0); -ELEMENTS[123] = Fluid3D([16702,16184,16281,16403],0); -ELEMENTS[124] = Fluid3D([16400,16702,16281,16689],0); -ELEMENTS[125] = Fluid3D([16400,16702,16689,16922],0); -ELEMENTS[126] = Fluid3D([16184,16400,16281,15548],0); -ELEMENTS[127] = Fluid3D([16281,16400,16689,16245],0); -ELEMENTS[128] = Fluid3D([16689,16281,16245,16446],0); -ELEMENTS[129] = Fluid3D([16689,16281,16446,16457],0); -ELEMENTS[130] = Fluid3D([16281,16400,16245,15548],0); -ELEMENTS[131] = Fluid3D([16702,16281,16689,16457],0); -ELEMENTS[132] = Fluid3D([16400,16689,16245,16644],0); -ELEMENTS[133] = Fluid3D([16400,16689,16644,16922],0); -ELEMENTS[134] = Fluid3D([16689,16245,16644,16696],0); -ELEMENTS[135] = Fluid3D([16245,16400,16644,16121],0); -ELEMENTS[136] = Fluid3D([16245,16400,16121,15548],0); -ELEMENTS[137] = Fluid3D([16245,16644,16696,16325],0); -ELEMENTS[138] = Fluid3D([16644,16696,16325,16800],0); -ELEMENTS[139] = Fluid3D([16644,16696,16800,17032],0); -ELEMENTS[140] = Fluid3D([16644,16696,17032,16689],0); -ELEMENTS[141] = Fluid3D([16245,16644,16325,16121],0); -ELEMENTS[142] = Fluid3D([16689,16245,16696,16446],0); -ELEMENTS[143] = Fluid3D([15795,15745,15417,16239],0); -ELEMENTS[144] = Fluid3D([15210,15200,14709,14643],0); -ELEMENTS[145] = Fluid3D([15210,15200,14643,15435],0); -ELEMENTS[146] = Fluid3D([14709,15210,14643,14509],0); -ELEMENTS[147] = Fluid3D([14709,15210,14509,15181],0); -ELEMENTS[148] = Fluid3D([14643,14709,14509,13869],0); -ELEMENTS[149] = Fluid3D([14709,14509,13869,14139],0); -ELEMENTS[150] = Fluid3D([14709,14509,14139,15181],0); -ELEMENTS[151] = Fluid3D([15200,14709,14643,14483],0); -ELEMENTS[152] = Fluid3D([14709,14643,14483,13869],0); -ELEMENTS[153] = Fluid3D([15200,14709,14483,14931],0); -ELEMENTS[154] = Fluid3D([15200,14709,14931,15417],0); -ELEMENTS[155] = Fluid3D([14709,14483,14931,14273],0); -ELEMENTS[156] = Fluid3D([14483,14931,14273,14619],0); -ELEMENTS[157] = Fluid3D([14709,14483,14273,13869],0); -ELEMENTS[158] = Fluid3D([15210,14643,14509,15045],0); -ELEMENTS[159] = Fluid3D([14509,13869,14139,13655],0); -ELEMENTS[160] = Fluid3D([14139,14509,13655,14569],0); -ELEMENTS[161] = Fluid3D([14509,13655,14569,14040],0); -ELEMENTS[162] = Fluid3D([14569,14509,14040,15045],0); -ELEMENTS[163] = Fluid3D([14509,13655,14040,13869],0); -ELEMENTS[164] = Fluid3D([13869,14139,13655,13238],0); -ELEMENTS[165] = Fluid3D([13655,13869,13238,13227],0); -ELEMENTS[166] = Fluid3D([13655,13869,13227,14040],0); -ELEMENTS[167] = Fluid3D([13238,13655,13227,12749],0); -ELEMENTS[168] = Fluid3D([13238,13655,12749,13364],0); -ELEMENTS[169] = Fluid3D([13238,13655,13364,14139],0); -ELEMENTS[170] = Fluid3D([13655,13227,12749,13100],0); -ELEMENTS[171] = Fluid3D([13655,13227,13100,14040],0); -ELEMENTS[172] = Fluid3D([13869,14139,13238,14273],0); -ELEMENTS[173] = Fluid3D([12749,13655,13100,13205],0); -ELEMENTS[174] = Fluid3D([12749,13655,13205,13364],0); -ELEMENTS[175] = Fluid3D([13655,13100,13205,13861],0); -ELEMENTS[176] = Fluid3D([13655,13100,13861,14040],0); -ELEMENTS[177] = Fluid3D([13861,13655,14040,14569],0); -ELEMENTS[178] = Fluid3D([14040,13861,14569,14585],0); -ELEMENTS[179] = Fluid3D([14040,13861,14585,13924],0); -ELEMENTS[180] = Fluid3D([14040,13861,13924,13100],0); -ELEMENTS[181] = Fluid3D([14585,14040,13924,14653],0); -ELEMENTS[182] = Fluid3D([14585,14040,14653,15045],0); -ELEMENTS[183] = Fluid3D([14040,13924,14653,13906],0); -ELEMENTS[184] = Fluid3D([14040,13924,13906,13100],0); -ELEMENTS[185] = Fluid3D([13861,14585,13924,14010],0); -ELEMENTS[186] = Fluid3D([13924,13861,14010,13252],0); -ELEMENTS[187] = Fluid3D([13924,13861,13252,13100],0); -ELEMENTS[188] = Fluid3D([13861,13252,13100,13205],0); -ELEMENTS[189] = Fluid3D([13861,14585,14010,14322],0); -ELEMENTS[190] = Fluid3D([13861,14585,14322,14569],0); -ELEMENTS[191] = Fluid3D([14653,14040,13906,14573],0); -ELEMENTS[192] = Fluid3D([14653,14040,14573,15045],0); -ELEMENTS[193] = Fluid3D([14573,14653,15045,15104],0); -ELEMENTS[194] = Fluid3D([14653,15045,15104,15369],0); -ELEMENTS[195] = Fluid3D([14653,15045,15369,14585],0); -ELEMENTS[196] = Fluid3D([15045,14573,15104,15435],0); -ELEMENTS[197] = Fluid3D([15045,15104,15369,15685],0); -ELEMENTS[198] = Fluid3D([15104,15369,15685,15518],0); -ELEMENTS[199] = Fluid3D([15369,15045,15685,15628],0); -ELEMENTS[200] = Fluid3D([15045,15104,15685,15435],0); -ELEMENTS[201] = Fluid3D([13861,14010,13252,13431],0); -ELEMENTS[202] = Fluid3D([14010,13861,14322,13431],0); -ELEMENTS[203] = Fluid3D([14569,14040,14585,15045],0); -ELEMENTS[204] = Fluid3D([13252,13861,13431,13205],0); -ELEMENTS[205] = Fluid3D([13861,13431,13205,14322],0); -ELEMENTS[206] = Fluid3D([15104,14653,15369,14935],0); -ELEMENTS[207] = Fluid3D([14040,13906,14573,13920],0); -ELEMENTS[208] = Fluid3D([14040,13906,13920,13227],0); -ELEMENTS[209] = Fluid3D([13924,14653,13906,14160],0); -ELEMENTS[210] = Fluid3D([14653,15369,14935,14871],0); -ELEMENTS[211] = Fluid3D([15369,14935,14871,15708],0); -ELEMENTS[212] = Fluid3D([13924,14653,14160,14871],0); -ELEMENTS[213] = Fluid3D([13906,14653,14573,15104],0); -ELEMENTS[214] = Fluid3D([13906,13924,14160,13303],0); -ELEMENTS[215] = Fluid3D([13906,13924,13303,13100],0); -ELEMENTS[216] = Fluid3D([13924,14160,13303,13687],0); -ELEMENTS[217] = Fluid3D([13924,14160,13687,14871],0); -ELEMENTS[218] = Fluid3D([13303,13924,13687,13252],0); -ELEMENTS[219] = Fluid3D([14160,13906,13303,13790],0); -ELEMENTS[220] = Fluid3D([13906,13303,13790,13154],0); -ELEMENTS[221] = Fluid3D([13906,13303,13154,13100],0); -ELEMENTS[222] = Fluid3D([14160,13906,13790,14484],0); -ELEMENTS[223] = Fluid3D([14160,13906,14484,14653],0); -ELEMENTS[224] = Fluid3D([14010,13924,13252,13687],0); -ELEMENTS[225] = Fluid3D([13906,14573,13920,13836],0); -ELEMENTS[226] = Fluid3D([13920,13906,13836,13327],0); -ELEMENTS[227] = Fluid3D([13906,14573,13836,15104],0); -ELEMENTS[228] = Fluid3D([13920,13906,13327,13227],0); -ELEMENTS[229] = Fluid3D([13327,13920,13227,13365],0); -ELEMENTS[230] = Fluid3D([13920,13227,13365,13869],0); -ELEMENTS[231] = Fluid3D([13920,13227,13869,14040],0); -ELEMENTS[232] = Fluid3D([13365,13920,13869,14643],0); -ELEMENTS[233] = Fluid3D([13920,13869,14643,14040],0); -ELEMENTS[234] = Fluid3D([13327,13920,13365,13836],0); -ELEMENTS[235] = Fluid3D([14010,13252,13431,13281],0); -ELEMENTS[236] = Fluid3D([13431,14010,13281,13870],0); -ELEMENTS[237] = Fluid3D([13252,13431,13281,12639],0); -ELEMENTS[238] = Fluid3D([13431,14010,13870,14322],0); -ELEMENTS[239] = Fluid3D([14935,14653,14871,14160],0); -ELEMENTS[240] = Fluid3D([14935,14653,14160,14484],0); -ELEMENTS[241] = Fluid3D([14160,14935,14484,14304],0); -ELEMENTS[242] = Fluid3D([14935,14484,14304,14978],0); -ELEMENTS[243] = Fluid3D([14935,14484,14978,15104],0); -ELEMENTS[244] = Fluid3D([14935,14484,15104,14653],0); -ELEMENTS[245] = Fluid3D([14304,14935,14978,15280],0); -ELEMENTS[246] = Fluid3D([14484,14304,14978,14369],0); -ELEMENTS[247] = Fluid3D([14160,14935,14304,14587],0); -ELEMENTS[248] = Fluid3D([14935,14304,14587,15280],0); -ELEMENTS[249] = Fluid3D([14978,14484,14369,14870],0); -ELEMENTS[250] = Fluid3D([14978,14484,14870,15104],0); -ELEMENTS[251] = Fluid3D([14160,14935,14587,14871],0); -ELEMENTS[252] = Fluid3D([14484,14304,14369,13790],0); -ELEMENTS[253] = Fluid3D([14484,14369,14870,13836],0); -ELEMENTS[254] = Fluid3D([14484,14160,14304,13790],0); -ELEMENTS[255] = Fluid3D([14369,14978,14870,14895],0); -ELEMENTS[256] = Fluid3D([14304,14978,14369,15078],0); -ELEMENTS[257] = Fluid3D([14978,14369,15078,14895],0); -ELEMENTS[258] = Fluid3D([14304,14978,15078,15280],0); -ELEMENTS[259] = Fluid3D([15369,15104,14935,15518],0); -ELEMENTS[260] = Fluid3D([14573,14040,13920,14643],0); -ELEMENTS[261] = Fluid3D([13920,14573,14643,13836],0); -ELEMENTS[262] = Fluid3D([14573,14643,13836,14907],0); -ELEMENTS[263] = Fluid3D([14573,14643,14907,15435],0); -ELEMENTS[264] = Fluid3D([13836,14573,14907,15104],0); -ELEMENTS[265] = Fluid3D([14573,14907,15104,15435],0); -ELEMENTS[266] = Fluid3D([14653,15369,14871,15204],0); -ELEMENTS[267] = Fluid3D([15369,14871,15204,15525],0); -ELEMENTS[268] = Fluid3D([14871,15204,15525,15058],0); -ELEMENTS[269] = Fluid3D([14871,15204,15058,14496],0); -ELEMENTS[270] = Fluid3D([15058,14871,14496,14356],0); -ELEMENTS[271] = Fluid3D([15525,14871,15058,15038],0); -ELEMENTS[272] = Fluid3D([15204,15058,14496,15316],0); -ELEMENTS[273] = Fluid3D([14871,15058,15038,14356],0); -ELEMENTS[274] = Fluid3D([14871,14496,14356,13687],0); -ELEMENTS[275] = Fluid3D([15204,15525,15058,15316],0); -ELEMENTS[276] = Fluid3D([15525,14871,15038,15708],0); -ELEMENTS[277] = Fluid3D([15369,14871,15525,15708],0); -ELEMENTS[278] = Fluid3D([15038,14871,14356,14587],0); -ELEMENTS[279] = Fluid3D([15038,14871,14587,14935],0); -ELEMENTS[280] = Fluid3D([14356,15038,14587,14365],0); -ELEMENTS[281] = Fluid3D([15038,14587,14365,15469],0); -ELEMENTS[282] = Fluid3D([14496,15058,14356,14381],0); -ELEMENTS[283] = Fluid3D([15058,14356,14381,14711],0); -ELEMENTS[284] = Fluid3D([15058,14356,14711,15038],0); -ELEMENTS[285] = Fluid3D([14356,14496,14381,13762],0); -ELEMENTS[286] = Fluid3D([14356,14496,13762,13687],0); -ELEMENTS[287] = Fluid3D([13762,14356,13687,13622],0); -ELEMENTS[288] = Fluid3D([13687,13762,13622,13048],0); -ELEMENTS[289] = Fluid3D([13687,13762,13048,13252],0); -ELEMENTS[290] = Fluid3D([14356,13687,13622,13994],0); -ELEMENTS[291] = Fluid3D([14356,13687,13994,14587],0); -ELEMENTS[292] = Fluid3D([13994,14356,14587,14365],0); -ELEMENTS[293] = Fluid3D([14587,13994,14365,14329],0); -ELEMENTS[294] = Fluid3D([13994,14365,14329,13830],0); -ELEMENTS[295] = Fluid3D([13994,14365,13830,13622],0); -ELEMENTS[296] = Fluid3D([14587,13994,14329,14304],0); -ELEMENTS[297] = Fluid3D([13994,14356,14365,13622],0); -ELEMENTS[298] = Fluid3D([14329,13994,13830,13507],0); -ELEMENTS[299] = Fluid3D([14329,13994,13507,14304],0); -ELEMENTS[300] = Fluid3D([13994,13830,13507,13178],0); -ELEMENTS[301] = Fluid3D([13994,13830,13178,13622],0); -ELEMENTS[302] = Fluid3D([13178,13994,13622,13687],0); -ELEMENTS[303] = Fluid3D([14365,14329,13830,14584],0); -ELEMENTS[304] = Fluid3D([13830,14365,14584,14351],0); -ELEMENTS[305] = Fluid3D([13830,14365,14351,13622],0); -ELEMENTS[306] = Fluid3D([13622,13687,13048,13178],0); -ELEMENTS[307] = Fluid3D([13507,13994,13178,13323],0); -ELEMENTS[308] = Fluid3D([14365,14587,14329,15469],0); -ELEMENTS[309] = Fluid3D([14365,14329,14584,15029],0); -ELEMENTS[310] = Fluid3D([13507,13994,13323,14304],0); -ELEMENTS[311] = Fluid3D([13762,13622,13048,13229],0); -ELEMENTS[312] = Fluid3D([14365,14584,14351,15105],0); -ELEMENTS[313] = Fluid3D([13762,14356,13622,14381],0); -ELEMENTS[314] = Fluid3D([14351,14365,15105,14711],0); -ELEMENTS[315] = Fluid3D([13762,13622,13229,14381],0); -ELEMENTS[316] = Fluid3D([13994,13178,13323,13687],0); -ELEMENTS[317] = Fluid3D([13323,13994,13687,14160],0); -ELEMENTS[318] = Fluid3D([13687,13323,14160,13303],0); -ELEMENTS[319] = Fluid3D([13687,13323,13303,13048],0); -ELEMENTS[320] = Fluid3D([13323,14160,13303,13790],0); -ELEMENTS[321] = Fluid3D([13048,13762,13229,13281],0); -ELEMENTS[322] = Fluid3D([14365,14584,15105,15469],0); -ELEMENTS[323] = Fluid3D([13830,13507,13178,12986],0); -ELEMENTS[324] = Fluid3D([13178,13830,12986,13177],0); -ELEMENTS[325] = Fluid3D([13178,13830,13177,13622],0); -ELEMENTS[326] = Fluid3D([13830,13507,12986,13697],0); -ELEMENTS[327] = Fluid3D([13830,13507,13697,14329],0); -ELEMENTS[328] = Fluid3D([13178,13507,13323,12619],0); -ELEMENTS[329] = Fluid3D([13507,13323,12619,13102],0); -ELEMENTS[330] = Fluid3D([12986,13830,13697,13566],0); -ELEMENTS[331] = Fluid3D([12986,13830,13566,13177],0); -ELEMENTS[332] = Fluid3D([12619,13507,13102,12845],0); -ELEMENTS[333] = Fluid3D([13507,13323,13102,14304],0); -ELEMENTS[334] = Fluid3D([13178,13507,12619,12986],0); -ELEMENTS[335] = Fluid3D([14329,13830,14584,13697],0); -ELEMENTS[336] = Fluid3D([12986,13178,13177,12358],0); -ELEMENTS[337] = Fluid3D([13178,13177,12358,12726],0); -ELEMENTS[338] = Fluid3D([13178,13177,12726,13622],0); -ELEMENTS[339] = Fluid3D([12726,13178,13622,13048],0); -ELEMENTS[340] = Fluid3D([12986,13178,12358,12619],0); -ELEMENTS[341] = Fluid3D([14584,14351,15105,14858],0); -ELEMENTS[342] = Fluid3D([15105,14584,14858,15253],0); -ELEMENTS[343] = Fluid3D([15105,14584,15253,15469],0); -ELEMENTS[344] = Fluid3D([14858,15105,15253,15472],0); -ELEMENTS[345] = Fluid3D([14584,14858,15253,14800],0); -ELEMENTS[346] = Fluid3D([15253,14584,14800,15029],0); -ELEMENTS[347] = Fluid3D([13323,13178,12619,12589],0); -ELEMENTS[348] = Fluid3D([15058,15525,15038,15894],0); -ELEMENTS[349] = Fluid3D([13622,13048,13229,12726],0); -ELEMENTS[350] = Fluid3D([13229,13622,12726,13599],0); -ELEMENTS[351] = Fluid3D([12726,13229,13599,12795],0); -ELEMENTS[352] = Fluid3D([12726,13229,12795,12289],0); -ELEMENTS[353] = Fluid3D([12726,13229,12289,13048],0); -ELEMENTS[354] = Fluid3D([13622,12726,13599,13177],0); -ELEMENTS[355] = Fluid3D([13599,12726,12795,12922],0); -ELEMENTS[356] = Fluid3D([13599,12726,12922,13177],0); -ELEMENTS[357] = Fluid3D([12726,12922,13177,12358],0); -ELEMENTS[358] = Fluid3D([12795,12726,12289,12046],0); -ELEMENTS[359] = Fluid3D([13229,12795,12289,12750],0); -ELEMENTS[360] = Fluid3D([12795,12726,12046,12922],0); -ELEMENTS[361] = Fluid3D([13229,13599,12795,13598],0); -ELEMENTS[362] = Fluid3D([13229,12795,12750,13598],0); -ELEMENTS[363] = Fluid3D([13229,13599,13598,14381],0); -ELEMENTS[364] = Fluid3D([12726,12289,12046,11988],0); -ELEMENTS[365] = Fluid3D([12726,12289,11988,13048],0); -ELEMENTS[366] = Fluid3D([12289,13229,12750,12709],0); -ELEMENTS[367] = Fluid3D([12289,13229,12709,13048],0); -ELEMENTS[368] = Fluid3D([13229,13622,13599,14381],0); -ELEMENTS[369] = Fluid3D([13229,12750,12709,13530],0); -ELEMENTS[370] = Fluid3D([13229,12750,13530,13598],0); -ELEMENTS[371] = Fluid3D([12289,12795,12046,11885],0); -ELEMENTS[372] = Fluid3D([12795,12046,11885,12220],0); -ELEMENTS[373] = Fluid3D([12795,12046,12220,12922],0); -ELEMENTS[374] = Fluid3D([13599,12795,13598,13454],0); -ELEMENTS[375] = Fluid3D([12795,13598,13454,12980],0); -ELEMENTS[376] = Fluid3D([12795,13598,12980,12750],0); -ELEMENTS[377] = Fluid3D([12046,12289,11885,11148],0); -ELEMENTS[378] = Fluid3D([12046,12289,11148,11988],0); -ELEMENTS[379] = Fluid3D([12709,13229,13530,13281],0); -ELEMENTS[380] = Fluid3D([13530,12709,13281,12918],0); -ELEMENTS[381] = Fluid3D([12709,13281,12918,12639],0); -ELEMENTS[382] = Fluid3D([12709,13281,12639,13252],0); -ELEMENTS[383] = Fluid3D([13281,13530,12918,13870],0); -ELEMENTS[384] = Fluid3D([12709,13229,13281,13048],0); -ELEMENTS[385] = Fluid3D([13530,12709,12918,12750],0); -ELEMENTS[386] = Fluid3D([12795,13599,12922,13454],0); -ELEMENTS[387] = Fluid3D([12795,12289,12750,11885],0); -ELEMENTS[388] = Fluid3D([12046,12726,11988,12358],0); -ELEMENTS[389] = Fluid3D([12726,11988,12358,12589],0); -ELEMENTS[390] = Fluid3D([13830,13697,13566,14584],0); -ELEMENTS[391] = Fluid3D([12750,12289,12709,11923],0); -ELEMENTS[392] = Fluid3D([12289,12709,11923,11879],0); -ELEMENTS[393] = Fluid3D([12289,12709,11879,13048],0); -ELEMENTS[394] = Fluid3D([12750,12289,11923,11885],0); -ELEMENTS[395] = Fluid3D([11923,12289,11879,11148],0); -ELEMENTS[396] = Fluid3D([14356,14381,14711,13622],0); -ELEMENTS[397] = Fluid3D([14584,13830,14351,13566],0); -ELEMENTS[398] = Fluid3D([14585,14010,14322,15099],0); -ELEMENTS[399] = Fluid3D([14322,14585,15099,14569],0); -ELEMENTS[400] = Fluid3D([14585,15099,14569,15045],0); -ELEMENTS[401] = Fluid3D([13323,12619,13102,12560],0); -ELEMENTS[402] = Fluid3D([13697,12986,13566,12987],0); -ELEMENTS[403] = Fluid3D([14496,15058,14381,15316],0); -ELEMENTS[404] = Fluid3D([13100,12749,13205,12335],0); -ELEMENTS[405] = Fluid3D([12749,13205,12335,12478],0); -ELEMENTS[406] = Fluid3D([12749,13205,12478,13364],0); -ELEMENTS[407] = Fluid3D([13100,12749,12335,12352],0); -ELEMENTS[408] = Fluid3D([13100,12749,12352,13227],0); -ELEMENTS[409] = Fluid3D([12749,12335,12352,11780],0); -ELEMENTS[410] = Fluid3D([12749,12335,11780,12478],0); -ELEMENTS[411] = Fluid3D([12335,12352,11780,11456],0); -ELEMENTS[412] = Fluid3D([11780,12335,11456,11512],0); -ELEMENTS[413] = Fluid3D([11780,12335,11512,12478],0); -ELEMENTS[414] = Fluid3D([12335,12352,11456,12247],0); -ELEMENTS[415] = Fluid3D([12335,12352,12247,13100],0); -ELEMENTS[416] = Fluid3D([11456,11780,11512,10781],0); -ELEMENTS[417] = Fluid3D([11456,11780,10781,11186],0); -ELEMENTS[418] = Fluid3D([11456,11780,11186,12352],0); -ELEMENTS[419] = Fluid3D([12352,11456,12247,11608],0); -ELEMENTS[420] = Fluid3D([11512,11456,10781,10708],0); -ELEMENTS[421] = Fluid3D([11456,12247,11608,11324],0); -ELEMENTS[422] = Fluid3D([12352,11456,11608,11186],0); -ELEMENTS[423] = Fluid3D([11456,12247,11324,11741],0); -ELEMENTS[424] = Fluid3D([11456,12247,11741,12335],0); -ELEMENTS[425] = Fluid3D([12247,11324,11741,11879],0); -ELEMENTS[426] = Fluid3D([11512,11456,10708,11741],0); -ELEMENTS[427] = Fluid3D([13507,12986,13697,12845],0); -ELEMENTS[428] = Fluid3D([13303,13790,13154,12560],0); -ELEMENTS[429] = Fluid3D([11885,12795,12220,12980],0); -ELEMENTS[430] = Fluid3D([14584,14351,14858,13566],0); -ELEMENTS[431] = Fluid3D([14483,15200,14931,15070],0); -ELEMENTS[432] = Fluid3D([14483,15200,15070,14896],0); -ELEMENTS[433] = Fluid3D([15200,15070,14896,15573],0); -ELEMENTS[434] = Fluid3D([14931,14483,15070,14619],0); -ELEMENTS[435] = Fluid3D([15200,15070,15573,15920],0); -ELEMENTS[436] = Fluid3D([14896,15200,15573,15435],0); -ELEMENTS[437] = Fluid3D([14483,15200,14896,14643],0); -ELEMENTS[438] = Fluid3D([15200,14931,15070,15920],0); -ELEMENTS[439] = Fluid3D([15070,14483,14896,14503],0); -ELEMENTS[440] = Fluid3D([14483,14896,14503,14083],0); -ELEMENTS[441] = Fluid3D([15070,14483,14503,14619],0); -ELEMENTS[442] = Fluid3D([14896,14503,14083,14467],0); -ELEMENTS[443] = Fluid3D([14083,14896,14467,14907],0); -ELEMENTS[444] = Fluid3D([14896,14503,14467,15071],0); -ELEMENTS[445] = Fluid3D([14896,14503,15071,15070],0); -ELEMENTS[446] = Fluid3D([14503,14083,14467,13710],0); -ELEMENTS[447] = Fluid3D([14503,14467,15071,14364],0); -ELEMENTS[448] = Fluid3D([14503,14083,13710,13301],0); -ELEMENTS[449] = Fluid3D([14503,14083,13301,14483],0); -ELEMENTS[450] = Fluid3D([14467,14503,13710,14364],0); -ELEMENTS[451] = Fluid3D([14483,14896,14083,14643],0); -ELEMENTS[452] = Fluid3D([14083,14467,13710,13782],0); -ELEMENTS[453] = Fluid3D([14083,14467,13782,13836],0); -ELEMENTS[454] = Fluid3D([13782,14083,13836,13365],0); -ELEMENTS[455] = Fluid3D([14083,13836,13365,14643],0); -ELEMENTS[456] = Fluid3D([14467,13710,13782,14045],0); -ELEMENTS[457] = Fluid3D([13782,14467,14045,14387],0); -ELEMENTS[458] = Fluid3D([13782,14467,14387,14870],0); -ELEMENTS[459] = Fluid3D([14467,13710,14045,14364],0); -ELEMENTS[460] = Fluid3D([14045,13782,14387,13574],0); -ELEMENTS[461] = Fluid3D([13782,14387,13574,13933],0); -ELEMENTS[462] = Fluid3D([13782,14387,13933,14870],0); -ELEMENTS[463] = Fluid3D([14045,13782,13574,13067],0); -ELEMENTS[464] = Fluid3D([14045,13782,13067,13710],0); -ELEMENTS[465] = Fluid3D([13782,13574,13067,13217],0); -ELEMENTS[466] = Fluid3D([13782,13574,13217,13933],0); -ELEMENTS[467] = Fluid3D([13067,13782,13217,12857],0); -ELEMENTS[468] = Fluid3D([13067,13782,12857,13710],0); -ELEMENTS[469] = Fluid3D([14387,14045,13574,14165],0); -ELEMENTS[470] = Fluid3D([13782,13217,12857,13836],0); -ELEMENTS[471] = Fluid3D([14387,14045,14165,15005],0); -ELEMENTS[472] = Fluid3D([14045,13574,14165,12970],0); -ELEMENTS[473] = Fluid3D([13710,14083,13782,13365],0); -ELEMENTS[474] = Fluid3D([14467,14045,14387,14789],0); -ELEMENTS[475] = Fluid3D([14467,14045,14789,14364],0); -ELEMENTS[476] = Fluid3D([14387,14467,14789,15179],0); -ELEMENTS[477] = Fluid3D([14045,14387,14789,15005],0); -ELEMENTS[478] = Fluid3D([13574,13067,13217,12651],0); -ELEMENTS[479] = Fluid3D([13574,13067,12651,12970],0); -ELEMENTS[480] = Fluid3D([13067,12651,12970,12420],0); -ELEMENTS[481] = Fluid3D([13067,13217,12651,12319],0); -ELEMENTS[482] = Fluid3D([13217,12651,12319,12193],0); -ELEMENTS[483] = Fluid3D([13217,12651,12193,13028],0); -ELEMENTS[484] = Fluid3D([13217,12651,13028,13574],0); -ELEMENTS[485] = Fluid3D([13067,13217,12319,12857],0); -ELEMENTS[486] = Fluid3D([12651,12319,12193,12031],0); -ELEMENTS[487] = Fluid3D([12651,12319,12031,12420],0); -ELEMENTS[488] = Fluid3D([12193,12651,12031,12590],0); -ELEMENTS[489] = Fluid3D([12651,12031,12590,12970],0); -ELEMENTS[490] = Fluid3D([12651,12031,12970,12420],0); -ELEMENTS[491] = Fluid3D([12590,12651,12970,13574],0); -ELEMENTS[492] = Fluid3D([12651,12193,13028,12590],0); -ELEMENTS[493] = Fluid3D([12651,13067,12319,12420],0); -ELEMENTS[494] = Fluid3D([15070,14896,15573,15071],0); -ELEMENTS[495] = Fluid3D([15071,14503,14364,14819],0); -ELEMENTS[496] = Fluid3D([15071,14503,14819,15070],0); -ELEMENTS[497] = Fluid3D([14503,14364,14819,13984],0); -ELEMENTS[498] = Fluid3D([14503,14364,13984,13710],0); -ELEMENTS[499] = Fluid3D([14819,14503,13984,14766],0); -ELEMENTS[500] = Fluid3D([13984,14819,14766,14536],0); -ELEMENTS[501] = Fluid3D([14819,14766,14536,15270],0); -ELEMENTS[502] = Fluid3D([14819,14766,15270,15597],0); -ELEMENTS[503] = Fluid3D([14536,14819,15270,14767],0); -ELEMENTS[504] = Fluid3D([14819,15270,14767,15071],0); -ELEMENTS[505] = Fluid3D([14536,14819,14767,13984],0); -ELEMENTS[506] = Fluid3D([14819,14503,14766,15070],0); -ELEMENTS[507] = Fluid3D([14819,15270,15071,15597],0); -ELEMENTS[508] = Fluid3D([14364,15071,14819,14767],0); -ELEMENTS[509] = Fluid3D([14819,14364,14767,13984],0); -ELEMENTS[510] = Fluid3D([14364,15071,14767,14789],0); -ELEMENTS[511] = Fluid3D([12352,12749,11780,12176],0); -ELEMENTS[512] = Fluid3D([12352,12749,12176,13227],0); -ELEMENTS[513] = Fluid3D([12749,11780,12176,12277],0); -ELEMENTS[514] = Fluid3D([12749,11780,12277,12478],0); -ELEMENTS[515] = Fluid3D([12176,12749,12277,13238],0); -ELEMENTS[516] = Fluid3D([11780,12352,12176,11186],0); -ELEMENTS[517] = Fluid3D([11780,12176,12277,11382],0); -ELEMENTS[518] = Fluid3D([11780,12176,11382,11186],0); -ELEMENTS[519] = Fluid3D([12176,12277,11382,12121],0); -ELEMENTS[520] = Fluid3D([12176,12277,12121,13238],0); -ELEMENTS[521] = Fluid3D([11382,12176,12121,11529],0); -ELEMENTS[522] = Fluid3D([12176,12121,11529,12497],0); -ELEMENTS[523] = Fluid3D([12176,12121,12497,13238],0); -ELEMENTS[524] = Fluid3D([11382,12176,11529,11186],0); -ELEMENTS[525] = Fluid3D([12277,11780,11382,11452],0); -ELEMENTS[526] = Fluid3D([12277,11780,11452,12478],0); -ELEMENTS[527] = Fluid3D([11780,11382,11452,10781],0); -ELEMENTS[528] = Fluid3D([11382,12277,11452,11639],0); -ELEMENTS[529] = Fluid3D([12277,11452,11639,12198],0); -ELEMENTS[530] = Fluid3D([12277,11452,12198,12478],0); -ELEMENTS[531] = Fluid3D([11382,12277,11639,12121],0); -ELEMENTS[532] = Fluid3D([11452,11639,12198,11242],0); -ELEMENTS[533] = Fluid3D([11452,11639,11242,10659],0); -ELEMENTS[534] = Fluid3D([11452,11639,10659,11382],0); -ELEMENTS[535] = Fluid3D([11639,12198,11242,11957],0); -ELEMENTS[536] = Fluid3D([11639,12198,11957,12521],0); -ELEMENTS[537] = Fluid3D([11639,12198,12521,12277],0); -ELEMENTS[538] = Fluid3D([11242,11639,11957,11021],0); -ELEMENTS[539] = Fluid3D([11639,11242,10659,11021],0); -ELEMENTS[540] = Fluid3D([11957,11242,11021,11177],0); -ELEMENTS[541] = Fluid3D([11957,11242,11177,11901],0); -ELEMENTS[542] = Fluid3D([11957,11242,11901,12198],0); -ELEMENTS[543] = Fluid3D([11242,11021,11177,10316],0); -ELEMENTS[544] = Fluid3D([11242,11021,10316,10659],0); -ELEMENTS[545] = Fluid3D([11021,11177,10316,10437],0); -ELEMENTS[546] = Fluid3D([11177,10316,10437,10304],0); -ELEMENTS[547] = Fluid3D([11177,10316,10304,10829],0); -ELEMENTS[548] = Fluid3D([11021,11177,10437,11446],0); -ELEMENTS[549] = Fluid3D([11177,10316,10829,11242],0); -ELEMENTS[550] = Fluid3D([11021,11177,11446,11957],0); -ELEMENTS[551] = Fluid3D([12198,11452,11242,11641],0); -ELEMENTS[552] = Fluid3D([12198,11452,11641,12478],0); -ELEMENTS[553] = Fluid3D([11452,11242,11641,10678],0); -ELEMENTS[554] = Fluid3D([11242,12198,11641,11901],0); -ELEMENTS[555] = Fluid3D([11452,11242,10678,10659],0); -ELEMENTS[556] = Fluid3D([11641,11452,10678,11274],0); -ELEMENTS[557] = Fluid3D([11641,11452,11274,12478],0); -ELEMENTS[558] = Fluid3D([11452,10678,11274,10781],0); -ELEMENTS[559] = Fluid3D([10678,11641,11274,11169],0); -ELEMENTS[560] = Fluid3D([11274,10678,11169,10255],0); -ELEMENTS[561] = Fluid3D([11274,10678,10255,10781],0); -ELEMENTS[562] = Fluid3D([10678,11641,11169,10829],0); -ELEMENTS[563] = Fluid3D([11641,11274,11169,11893],0); -ELEMENTS[564] = Fluid3D([11641,11274,11893,12478],0); -ELEMENTS[565] = Fluid3D([11274,11169,11893,11110],0); -ELEMENTS[566] = Fluid3D([11274,11169,11110,10255],0); -ELEMENTS[567] = Fluid3D([11169,11893,11110,11378],0); -ELEMENTS[568] = Fluid3D([11169,11641,11893,11717],0); -ELEMENTS[569] = Fluid3D([11169,11641,11717,10829],0); -ELEMENTS[570] = Fluid3D([11169,11893,11378,11717],0); -ELEMENTS[571] = Fluid3D([11893,11110,11378,11997],0); -ELEMENTS[572] = Fluid3D([11893,11110,11997,11965],0); -ELEMENTS[573] = Fluid3D([11893,11110,11965,11274],0); -ELEMENTS[574] = Fluid3D([11110,11378,11997,11096],0); -ELEMENTS[575] = Fluid3D([11378,11997,11096,11951],0); -ELEMENTS[576] = Fluid3D([11997,11096,11951,11932],0); -ELEMENTS[577] = Fluid3D([11997,11096,11932,11498],0); -ELEMENTS[578] = Fluid3D([11997,11096,11498,11110],0); -ELEMENTS[579] = Fluid3D([11378,11893,11997,12298],0); -ELEMENTS[580] = Fluid3D([11893,11997,12298,12763],0); -ELEMENTS[581] = Fluid3D([11893,11997,12763,11965],0); -ELEMENTS[582] = Fluid3D([11378,11893,12298,11717],0); -ELEMENTS[583] = Fluid3D([11110,11378,11096,10392],0); -ELEMENTS[584] = Fluid3D([11096,11110,10392,10356],0); -ELEMENTS[585] = Fluid3D([11378,11096,10392,10825],0); -ELEMENTS[586] = Fluid3D([11378,11096,10825,11951],0); -ELEMENTS[587] = Fluid3D([11110,11378,10392,11169],0); -ELEMENTS[588] = Fluid3D([11096,11110,10356,11498],0); -ELEMENTS[589] = Fluid3D([11378,11997,11951,12298],0); -ELEMENTS[590] = Fluid3D([12198,11957,12521,12969],0); -ELEMENTS[591] = Fluid3D([12521,12198,12969,13117],0); -ELEMENTS[592] = Fluid3D([11957,12521,12969,12631],0); -ELEMENTS[593] = Fluid3D([11957,12521,12631,12025],0); -ELEMENTS[594] = Fluid3D([12521,12631,12025,13201],0); -ELEMENTS[595] = Fluid3D([12521,12631,13201,12969],0); -ELEMENTS[596] = Fluid3D([12631,12025,13201,12439],0); -ELEMENTS[597] = Fluid3D([13201,12631,12439,13280],0); -ELEMENTS[598] = Fluid3D([12631,12439,13280,12380],0); -ELEMENTS[599] = Fluid3D([12631,12439,12380,11957],0); -ELEMENTS[600] = Fluid3D([13201,12631,13280,12969],0); -ELEMENTS[601] = Fluid3D([12380,12631,11957,12969],0); -ELEMENTS[602] = Fluid3D([11957,12380,12969,11901],0); -ELEMENTS[603] = Fluid3D([13280,12631,12380,12969],0); -ELEMENTS[604] = Fluid3D([12631,12025,12439,11957],0); -ELEMENTS[605] = Fluid3D([11957,12380,11901,11177],0); -ELEMENTS[606] = Fluid3D([12198,11957,12969,11901],0); -ELEMENTS[607] = Fluid3D([11957,12521,12025,11639],0); -ELEMENTS[608] = Fluid3D([12198,12969,13117,12871],0); -ELEMENTS[609] = Fluid3D([12198,12969,12871,11901],0); -ELEMENTS[610] = Fluid3D([12969,13117,12871,13648],0); -ELEMENTS[611] = Fluid3D([13117,12871,13648,13589],0); -ELEMENTS[612] = Fluid3D([13648,13117,13589,14005],0); -ELEMENTS[613] = Fluid3D([13117,12871,13589,12478],0); -ELEMENTS[614] = Fluid3D([13648,13117,14005,13628],0); -ELEMENTS[615] = Fluid3D([13117,14005,13628,13541],0); -ELEMENTS[616] = Fluid3D([13648,13117,13628,12969],0); -ELEMENTS[617] = Fluid3D([13117,14005,13541,13364],0); -ELEMENTS[618] = Fluid3D([13117,14005,13364,13589],0); -ELEMENTS[619] = Fluid3D([13364,13117,13589,12478],0); -ELEMENTS[620] = Fluid3D([13541,13117,13364,12277],0); -ELEMENTS[621] = Fluid3D([14005,13364,13589,14140],0); -ELEMENTS[622] = Fluid3D([13364,13589,14140,13205],0); -ELEMENTS[623] = Fluid3D([14005,13364,14140,14139],0); -ELEMENTS[624] = Fluid3D([14005,13541,13364,14139],0); -ELEMENTS[625] = Fluid3D([14005,13541,14139,14357],0); -ELEMENTS[626] = Fluid3D([13541,14139,14357,14273],0); -ELEMENTS[627] = Fluid3D([13589,14005,14140,14428],0); -ELEMENTS[628] = Fluid3D([14140,13589,14428,13971],0); -ELEMENTS[629] = Fluid3D([14140,13589,13971,13205],0); -ELEMENTS[630] = Fluid3D([14428,14140,13971,15055],0); -ELEMENTS[631] = Fluid3D([14005,13541,14357,13628],0); -ELEMENTS[632] = Fluid3D([13589,14428,13971,13805],0); -ELEMENTS[633] = Fluid3D([13971,13589,13805,13179],0); -ELEMENTS[634] = Fluid3D([13589,14428,13805,13648],0); -ELEMENTS[635] = Fluid3D([13971,13589,13179,13205],0); -ELEMENTS[636] = Fluid3D([13589,13805,13179,12871],0); -ELEMENTS[637] = Fluid3D([13589,14005,14428,13648],0); -ELEMENTS[638] = Fluid3D([14005,14140,14428,14727],0); -ELEMENTS[639] = Fluid3D([14428,14005,14727,14694],0); -ELEMENTS[640] = Fluid3D([14428,14005,14694,13648],0); -ELEMENTS[641] = Fluid3D([14005,14140,14727,14139],0); -ELEMENTS[642] = Fluid3D([14428,13971,13805,14725],0); -ELEMENTS[643] = Fluid3D([13971,13805,14725,14105],0); -ELEMENTS[644] = Fluid3D([13805,14428,14725,14517],0); -ELEMENTS[645] = Fluid3D([13805,14428,14517,13648],0); -ELEMENTS[646] = Fluid3D([14428,13971,14725,15055],0); -ELEMENTS[647] = Fluid3D([13971,13805,14105,13179],0); -ELEMENTS[648] = Fluid3D([12871,12969,13648,13023],0); -ELEMENTS[649] = Fluid3D([12871,12969,13023,11901],0); -ELEMENTS[650] = Fluid3D([12969,13648,13023,14073],0); -ELEMENTS[651] = Fluid3D([13648,12871,13023,13805],0); -ELEMENTS[652] = Fluid3D([14725,13971,14105,14670],0); -ELEMENTS[653] = Fluid3D([13971,14105,14670,13855],0); -ELEMENTS[654] = Fluid3D([14105,14670,13855,14316],0); -ELEMENTS[655] = Fluid3D([14105,14725,14670,14881],0); -ELEMENTS[656] = Fluid3D([14105,14725,14881,14480],0); -ELEMENTS[657] = Fluid3D([14105,14725,14480,13805],0); -ELEMENTS[658] = Fluid3D([14725,13971,14670,15055],0); -ELEMENTS[659] = Fluid3D([13971,14105,13855,13179],0); -ELEMENTS[660] = Fluid3D([14105,14670,14316,14881],0); -ELEMENTS[661] = Fluid3D([14670,13855,14316,14465],0); -ELEMENTS[662] = Fluid3D([13855,14316,14465,13773],0); -ELEMENTS[663] = Fluid3D([14316,14670,14465,15062],0); -ELEMENTS[664] = Fluid3D([14316,14465,13773,14355],0); -ELEMENTS[665] = Fluid3D([14316,14465,14355,15062],0); -ELEMENTS[666] = Fluid3D([14670,13855,14465,14322],0); -ELEMENTS[667] = Fluid3D([13855,14316,13773,13433],0); -ELEMENTS[668] = Fluid3D([13855,14316,13433,14105],0); -ELEMENTS[669] = Fluid3D([14316,13773,13433,14025],0); -ELEMENTS[670] = Fluid3D([13433,14316,14025,14097],0); -ELEMENTS[671] = Fluid3D([13433,14316,14097,14105],0); -ELEMENTS[672] = Fluid3D([13773,13855,13433,13036],0); -ELEMENTS[673] = Fluid3D([13855,13433,13036,12763],0); -ELEMENTS[674] = Fluid3D([13773,13855,13036,13870],0); -ELEMENTS[675] = Fluid3D([14316,14670,15062,14881],0); -ELEMENTS[676] = Fluid3D([14316,13773,14025,14355],0); -ELEMENTS[677] = Fluid3D([12521,12198,13117,12277],0); -ELEMENTS[678] = Fluid3D([12121,11529,12497,11933],0); -ELEMENTS[679] = Fluid3D([11529,12497,11933,11905],0); -ELEMENTS[680] = Fluid3D([12121,11529,11933,11201],0); -ELEMENTS[681] = Fluid3D([12497,12121,11933,12835],0); -ELEMENTS[682] = Fluid3D([12497,12121,12835,13238],0); -ELEMENTS[683] = Fluid3D([11933,11529,11905,11023],0); -ELEMENTS[684] = Fluid3D([11933,11529,11023,11201],0); -ELEMENTS[685] = Fluid3D([11529,11905,11023,10998],0); -ELEMENTS[686] = Fluid3D([11905,11023,10998,10888],0); -ELEMENTS[687] = Fluid3D([11529,11905,10998,11977],0); -ELEMENTS[688] = Fluid3D([11905,10998,11977,11602],0); -ELEMENTS[689] = Fluid3D([11905,10998,11602,10888],0); -ELEMENTS[690] = Fluid3D([10998,11602,10888,10441],0); -ELEMENTS[691] = Fluid3D([11529,11905,11977,12497],0); -ELEMENTS[692] = Fluid3D([12121,11529,11201,11382],0); -ELEMENTS[693] = Fluid3D([10998,11977,11602,11199],0); -ELEMENTS[694] = Fluid3D([10998,11977,11199,11186],0); -ELEMENTS[695] = Fluid3D([11977,11602,11199,12319],0); -ELEMENTS[696] = Fluid3D([11602,10998,11199,10441],0); -ELEMENTS[697] = Fluid3D([11023,11529,10998,10475],0); -ELEMENTS[698] = Fluid3D([11023,11529,10475,11201],0); -ELEMENTS[699] = Fluid3D([10998,11023,10475,10319],0); -ELEMENTS[700] = Fluid3D([11529,10998,10475,11186],0); -ELEMENTS[701] = Fluid3D([12497,11933,11905,12668],0); -ELEMENTS[702] = Fluid3D([12497,11933,12668,12835],0); -ELEMENTS[703] = Fluid3D([11933,11905,12668,11811],0); -ELEMENTS[704] = Fluid3D([11905,12668,11811,12374],0); -ELEMENTS[705] = Fluid3D([12668,11811,12374,13114],0); -ELEMENTS[706] = Fluid3D([11905,12497,12668,12430],0); -ELEMENTS[707] = Fluid3D([12497,12668,12430,13301],0); -ELEMENTS[708] = Fluid3D([11905,12497,12430,11977],0); -ELEMENTS[709] = Fluid3D([11905,12668,12374,12430],0); -ELEMENTS[710] = Fluid3D([11933,11905,11811,11023],0); -ELEMENTS[711] = Fluid3D([11811,11905,12374,11417],0); -ELEMENTS[712] = Fluid3D([12374,11811,11417,12347],0); -ELEMENTS[713] = Fluid3D([11417,12374,12347,11869],0); -ELEMENTS[714] = Fluid3D([12374,12347,11869,12974],0); -ELEMENTS[715] = Fluid3D([11417,12374,11869,11905],0); -ELEMENTS[716] = Fluid3D([12668,11933,11811,12424],0); -ELEMENTS[717] = Fluid3D([11811,12668,12424,13114],0); -ELEMENTS[718] = Fluid3D([12668,11933,12424,12835],0); -ELEMENTS[719] = Fluid3D([11933,11811,12424,11436],0); -ELEMENTS[720] = Fluid3D([11811,12424,11436,12309],0); -ELEMENTS[721] = Fluid3D([12424,11436,12309,12328],0); -ELEMENTS[722] = Fluid3D([12309,12424,12328,13124],0); -ELEMENTS[723] = Fluid3D([12309,12424,13124,13114],0); -ELEMENTS[724] = Fluid3D([12424,12328,13124,12835],0); -ELEMENTS[725] = Fluid3D([11811,12424,12309,13114],0); -ELEMENTS[726] = Fluid3D([11933,11811,11436,11023],0); -ELEMENTS[727] = Fluid3D([12424,11933,11436,12328],0); -ELEMENTS[728] = Fluid3D([14670,14465,15062,15254],0); -ELEMENTS[729] = Fluid3D([12969,12521,13117,13628],0); -ELEMENTS[730] = Fluid3D([11242,11641,10678,10829],0); -ELEMENTS[731] = Fluid3D([11324,11456,11741,10708],0); -ELEMENTS[732] = Fluid3D([10392,11096,10356,10105],0); -ELEMENTS[733] = Fluid3D([11096,10356,10105,10671],0); -ELEMENTS[734] = Fluid3D([10356,10392,10105,9478],0); -ELEMENTS[735] = Fluid3D([10392,10105,9478,9652],0); -ELEMENTS[736] = Fluid3D([9478,10392,9652,9571],0); -ELEMENTS[737] = Fluid3D([9478,10392,9571,10255],0); -ELEMENTS[738] = Fluid3D([10392,11096,10105,10825],0); -ELEMENTS[739] = Fluid3D([10392,10105,9652,10825],0); -ELEMENTS[740] = Fluid3D([10356,10105,10671,9665],0); -ELEMENTS[741] = Fluid3D([10356,10105,9665,9478],0); -ELEMENTS[742] = Fluid3D([10105,10671,9665,9944],0); -ELEMENTS[743] = Fluid3D([10105,10671,9944,10851],0); -ELEMENTS[744] = Fluid3D([10105,10671,10851,11096],0); -ELEMENTS[745] = Fluid3D([9665,10105,9944,9179],0); -ELEMENTS[746] = Fluid3D([10105,9944,9179,9832],0); -ELEMENTS[747] = Fluid3D([10105,9944,9832,10851],0); -ELEMENTS[748] = Fluid3D([9665,10105,9179,9478],0); -ELEMENTS[749] = Fluid3D([10671,10356,9665,10340],0); -ELEMENTS[750] = Fluid3D([10671,10356,10340,11498],0); -ELEMENTS[751] = Fluid3D([10356,9665,10340,9477],0); -ELEMENTS[752] = Fluid3D([9665,10671,10340,10084],0); -ELEMENTS[753] = Fluid3D([9665,10340,9477,9374],0); -ELEMENTS[754] = Fluid3D([9665,10340,9374,10084],0); -ELEMENTS[755] = Fluid3D([9665,10671,10084,9944],0); -ELEMENTS[756] = Fluid3D([10671,10340,10084,11079],0); -ELEMENTS[757] = Fluid3D([10671,10340,11079,11498],0); -ELEMENTS[758] = Fluid3D([10340,10084,11079,10361],0); -ELEMENTS[759] = Fluid3D([10084,11079,10361,10699],0); -ELEMENTS[760] = Fluid3D([10084,10671,11079,10874],0); -ELEMENTS[761] = Fluid3D([10084,10671,10874,9944],0); -ELEMENTS[762] = Fluid3D([10084,11079,10699,10874],0); -ELEMENTS[763] = Fluid3D([10340,10084,10361,9374],0); -ELEMENTS[764] = Fluid3D([11079,10340,10361,11089],0); -ELEMENTS[765] = Fluid3D([10340,10361,11089,10104],0); -ELEMENTS[766] = Fluid3D([10361,11079,11089,11148],0); -ELEMENTS[767] = Fluid3D([11079,10340,11089,11498],0); -ELEMENTS[768] = Fluid3D([10340,10361,10104,9374],0); -ELEMENTS[769] = Fluid3D([10361,11089,10104,11148],0); -ELEMENTS[770] = Fluid3D([10356,9665,9477,9478],0); -ELEMENTS[771] = Fluid3D([11096,10356,10671,11498],0); -ELEMENTS[772] = Fluid3D([10356,10392,9478,10255],0); -ELEMENTS[773] = Fluid3D([9652,9478,9571,8779],0); -ELEMENTS[774] = Fluid3D([9652,9478,8779,9179],0); -ELEMENTS[775] = Fluid3D([9478,9571,8779,8916],0); -ELEMENTS[776] = Fluid3D([9478,9571,8916,10255],0); -ELEMENTS[777] = Fluid3D([9571,9652,8779,9182],0); -ELEMENTS[778] = Fluid3D([9652,8779,9182,8845],0); -ELEMENTS[779] = Fluid3D([8779,9182,8845,8225],0); -ELEMENTS[780] = Fluid3D([8779,9478,8916,8686],0); -ELEMENTS[781] = Fluid3D([8779,9182,8225,8615],0); -ELEMENTS[782] = Fluid3D([8779,9182,8615,9571],0); -ELEMENTS[783] = Fluid3D([8779,9478,8686,9179],0); -ELEMENTS[784] = Fluid3D([9652,8779,8845,9179],0); -ELEMENTS[785] = Fluid3D([9571,9652,9182,10173],0); -ELEMENTS[786] = Fluid3D([9182,9571,10173,9636],0); -ELEMENTS[787] = Fluid3D([9652,9182,10173,9780],0); -ELEMENTS[788] = Fluid3D([9571,9652,10173,10392],0); -ELEMENTS[789] = Fluid3D([9652,9182,9780,8845],0); -ELEMENTS[790] = Fluid3D([9182,9571,9636,8615],0); -ELEMENTS[791] = Fluid3D([10173,9182,9636,9773],0); -ELEMENTS[792] = Fluid3D([9636,10173,9773,10566],0); -ELEMENTS[793] = Fluid3D([10173,9182,9773,9780],0); -ELEMENTS[794] = Fluid3D([9182,9636,9773,8891],0); -ELEMENTS[795] = Fluid3D([9636,9773,8891,9690],0); -ELEMENTS[796] = Fluid3D([9182,9636,8891,8615],0); -ELEMENTS[797] = Fluid3D([9636,9773,9690,10566],0); -ELEMENTS[798] = Fluid3D([9636,10173,10566,10674],0); -ELEMENTS[799] = Fluid3D([9636,10173,10674,9571],0); -ELEMENTS[800] = Fluid3D([10173,10566,10674,11281],0); -ELEMENTS[801] = Fluid3D([10566,9636,10674,10829],0); -ELEMENTS[802] = Fluid3D([10566,10674,11281,11717],0); -ELEMENTS[803] = Fluid3D([10674,11281,11717,11378],0); -ELEMENTS[804] = Fluid3D([11281,11717,11378,12298],0); -ELEMENTS[805] = Fluid3D([9182,8845,8225,8737],0); -ELEMENTS[806] = Fluid3D([9182,8845,8737,9780],0); -ELEMENTS[807] = Fluid3D([8845,8225,8737,8051],0); -ELEMENTS[808] = Fluid3D([8225,8737,8051,7836],0); -ELEMENTS[809] = Fluid3D([8225,8737,7836,8891],0); -ELEMENTS[810] = Fluid3D([8225,9182,8737,8891],0); -ELEMENTS[811] = Fluid3D([8737,8845,8051,8848],0); -ELEMENTS[812] = Fluid3D([8737,8845,8848,9780],0); -ELEMENTS[813] = Fluid3D([8051,8737,8848,8250],0); -ELEMENTS[814] = Fluid3D([8051,8737,8250,7836],0); -ELEMENTS[815] = Fluid3D([8845,8051,8848,8430],0); -ELEMENTS[816] = Fluid3D([8845,8051,8430,8090],0); -ELEMENTS[817] = Fluid3D([8845,8051,8090,8225],0); -ELEMENTS[818] = Fluid3D([8051,8848,8430,8050],0); -ELEMENTS[819] = Fluid3D([8848,8430,8050,8840],0); -ELEMENTS[820] = Fluid3D([8848,8430,8840,9377],0); -ELEMENTS[821] = Fluid3D([8051,8848,8050,8250],0); -ELEMENTS[822] = Fluid3D([8848,8430,9377,8845],0); -ELEMENTS[823] = Fluid3D([8737,8848,8250,9190],0); -ELEMENTS[824] = Fluid3D([8848,8250,9190,8795],0); -ELEMENTS[825] = Fluid3D([8848,8250,8795,8050],0); -ELEMENTS[826] = Fluid3D([8737,8848,9190,9780],0); -ELEMENTS[827] = Fluid3D([8430,8051,8050,7524],0); -ELEMENTS[828] = Fluid3D([8051,8050,7524,7329],0); -ELEMENTS[829] = Fluid3D([8050,8430,7524,7950],0); -ELEMENTS[830] = Fluid3D([8050,8430,7950,8840],0); -ELEMENTS[831] = Fluid3D([8430,8051,7524,8090],0); -ELEMENTS[832] = Fluid3D([8250,9190,8795,8639],0); -ELEMENTS[833] = Fluid3D([9190,8795,8639,9519],0); -ELEMENTS[834] = Fluid3D([9190,8795,9519,9710],0); -ELEMENTS[835] = Fluid3D([9190,8795,9710,8848],0); -ELEMENTS[836] = Fluid3D([8250,9190,8639,8692],0); -ELEMENTS[837] = Fluid3D([9190,8639,8692,9385],0); -ELEMENTS[838] = Fluid3D([8250,9190,8692,8737],0); -ELEMENTS[839] = Fluid3D([9190,8639,9385,9519],0); -ELEMENTS[840] = Fluid3D([8795,8639,9519,8783],0); -ELEMENTS[841] = Fluid3D([8795,8639,8783,7992],0); -ELEMENTS[842] = Fluid3D([9519,8795,8783,9419],0); -ELEMENTS[843] = Fluid3D([9519,8795,9419,9710],0); -ELEMENTS[844] = Fluid3D([8795,8783,9419,8492],0); -ELEMENTS[845] = Fluid3D([8795,8783,8492,7992],0); -ELEMENTS[846] = Fluid3D([9419,8795,8492,8840],0); -ELEMENTS[847] = Fluid3D([8639,9519,8783,9177],0); -ELEMENTS[848] = Fluid3D([9519,8783,9177,9685],0); -ELEMENTS[849] = Fluid3D([9519,8783,9685,9419],0); -ELEMENTS[850] = Fluid3D([8783,8639,9177,8217],0); -ELEMENTS[851] = Fluid3D([9177,8783,8217,8820],0); -ELEMENTS[852] = Fluid3D([9177,8783,8820,9685],0); -ELEMENTS[853] = Fluid3D([8783,8639,8217,7992],0); -ELEMENTS[854] = Fluid3D([8639,9519,9177,9385],0); -ELEMENTS[855] = Fluid3D([8795,8639,7992,8250],0); -ELEMENTS[856] = Fluid3D([8051,8050,7329,8250],0); -ELEMENTS[857] = Fluid3D([10173,10566,11281,10817],0); -ELEMENTS[858] = Fluid3D([10173,10566,10817,9773],0); -ELEMENTS[859] = Fluid3D([10566,11281,10817,11532],0); -ELEMENTS[860] = Fluid3D([10817,10566,11532,10755],0); -ELEMENTS[861] = Fluid3D([10817,10566,10755,9773],0); -ELEMENTS[862] = Fluid3D([10566,11281,11532,11717],0); -ELEMENTS[863] = Fluid3D([11281,11532,11717,12140],0); -ELEMENTS[864] = Fluid3D([11717,11281,12140,12298],0); -ELEMENTS[865] = Fluid3D([11281,11532,12140,10817],0); -ELEMENTS[866] = Fluid3D([11281,10173,10817,10825],0); -ELEMENTS[867] = Fluid3D([10566,11532,10755,11099],0); -ELEMENTS[868] = Fluid3D([11532,10755,11099,11690],0); -ELEMENTS[869] = Fluid3D([10755,11099,11690,10819],0); -ELEMENTS[870] = Fluid3D([10755,11099,10819,9690],0); -ELEMENTS[871] = Fluid3D([11099,11690,10819,11581],0); -ELEMENTS[872] = Fluid3D([11099,11690,11581,12113],0); -ELEMENTS[873] = Fluid3D([11690,10819,11581,11703],0); -ELEMENTS[874] = Fluid3D([11690,10819,11703,11189],0); -ELEMENTS[875] = Fluid3D([11690,10819,11189,10755],0); -ELEMENTS[876] = Fluid3D([11099,11690,12113,11532],0); -ELEMENTS[877] = Fluid3D([10566,11532,11099,11388],0); -ELEMENTS[878] = Fluid3D([11532,11099,11388,12113],0); -ELEMENTS[879] = Fluid3D([10566,11532,11388,11717],0); -ELEMENTS[880] = Fluid3D([10755,10566,11099,9690],0); -ELEMENTS[881] = Fluid3D([11099,10566,11388,10829],0); -ELEMENTS[882] = Fluid3D([11532,10755,11690,11643],0); -ELEMENTS[883] = Fluid3D([10755,11690,11643,11189],0); -ELEMENTS[884] = Fluid3D([11532,10755,11643,10817],0); -ELEMENTS[885] = Fluid3D([11690,11532,11643,12334],0); -ELEMENTS[886] = Fluid3D([11690,11532,12334,12113],0); -ELEMENTS[887] = Fluid3D([11532,11643,12334,12140],0); -ELEMENTS[888] = Fluid3D([11643,11690,12334,12388],0); -ELEMENTS[889] = Fluid3D([11643,11690,12388,11189],0); -ELEMENTS[890] = Fluid3D([11690,12334,12388,12641],0); -ELEMENTS[891] = Fluid3D([11690,12334,12641,12113],0); -ELEMENTS[892] = Fluid3D([12388,11690,12641,11703],0); -ELEMENTS[893] = Fluid3D([12334,11643,12388,12442],0); -ELEMENTS[894] = Fluid3D([11643,12388,12442,11909],0); -ELEMENTS[895] = Fluid3D([12334,11643,12442,12184],0); -ELEMENTS[896] = Fluid3D([12334,11643,12184,12140],0); -ELEMENTS[897] = Fluid3D([12442,12334,12184,13140],0); -ELEMENTS[898] = Fluid3D([12334,12184,13140,12140],0); -ELEMENTS[899] = Fluid3D([12442,12334,13140,13153],0); -ELEMENTS[900] = Fluid3D([12334,13140,13153,13261],0); -ELEMENTS[901] = Fluid3D([12334,13140,13261,12611],0); -ELEMENTS[902] = Fluid3D([12442,12334,13153,12388],0); -ELEMENTS[903] = Fluid3D([12334,13140,12611,12140],0); -ELEMENTS[904] = Fluid3D([13140,12611,12140,13001],0); -ELEMENTS[905] = Fluid3D([12611,12140,13001,12298],0); -ELEMENTS[906] = Fluid3D([12140,13001,12298,12502],0); -ELEMENTS[907] = Fluid3D([13001,12298,12502,13433],0); -ELEMENTS[908] = Fluid3D([12611,12140,12298,11717],0); -ELEMENTS[909] = Fluid3D([12298,12140,12502,11951],0); -ELEMENTS[910] = Fluid3D([12502,12298,11951,12767],0); -ELEMENTS[911] = Fluid3D([11951,12502,12767,12425],0); -ELEMENTS[912] = Fluid3D([11951,12502,12425,11640],0); -ELEMENTS[913] = Fluid3D([11951,12502,11640,11400],0); -ELEMENTS[914] = Fluid3D([11951,12502,11400,12140],0); -ELEMENTS[915] = Fluid3D([12502,11400,12140,11863],0); -ELEMENTS[916] = Fluid3D([11400,12140,11863,10817],0); -ELEMENTS[917] = Fluid3D([12502,12767,12425,13101],0); -ELEMENTS[918] = Fluid3D([12502,12425,11640,12526],0); -ELEMENTS[919] = Fluid3D([12502,11640,11400,11863],0); -ELEMENTS[920] = Fluid3D([11640,11951,11400,10825],0); -ELEMENTS[921] = Fluid3D([11951,11400,10825,11378],0); -ELEMENTS[922] = Fluid3D([11400,10825,11378,11281],0); -ELEMENTS[923] = Fluid3D([11378,11400,11281,12140],0); -ELEMENTS[924] = Fluid3D([11400,11281,12140,10817],0); -ELEMENTS[925] = Fluid3D([11951,11400,11378,12298],0); -ELEMENTS[926] = Fluid3D([11378,11400,12140,12298],0); -ELEMENTS[927] = Fluid3D([12502,12767,13101,13433],0); -ELEMENTS[928] = Fluid3D([12425,11951,11640,11518],0); -ELEMENTS[929] = Fluid3D([12502,12425,12526,13101],0); -ELEMENTS[930] = Fluid3D([12526,12502,13101,12781],0); -ELEMENTS[931] = Fluid3D([13101,12526,12781,13298],0); -ELEMENTS[932] = Fluid3D([13101,12526,13298,13189],0); -ELEMENTS[933] = Fluid3D([13101,12526,13189,12425],0); -ELEMENTS[934] = Fluid3D([11400,11640,10825,10919],0); -ELEMENTS[935] = Fluid3D([10825,11400,10919,10817],0); -ELEMENTS[936] = Fluid3D([11640,12502,12526,11863],0); -ELEMENTS[937] = Fluid3D([11951,11640,11518,10825],0); -ELEMENTS[938] = Fluid3D([12425,11951,11518,11932],0); -ELEMENTS[939] = Fluid3D([12502,12298,12767,13433],0); -ELEMENTS[940] = Fluid3D([11400,10825,11281,10817],0); -ELEMENTS[941] = Fluid3D([11400,12140,12298,11951],0); -ELEMENTS[942] = Fluid3D([12767,11951,12425,11932],0); -ELEMENTS[943] = Fluid3D([12611,12140,11717,11532],0); -ELEMENTS[944] = Fluid3D([11640,11400,11863,10919],0); -ELEMENTS[945] = Fluid3D([11400,11863,10919,10817],0); -ELEMENTS[946] = Fluid3D([12502,13101,12781,13001],0); -ELEMENTS[947] = Fluid3D([12781,12502,13001,12140],0); -ELEMENTS[948] = Fluid3D([13101,12781,13001,13716],0); -ELEMENTS[949] = Fluid3D([12781,13001,13716,13140],0); -ELEMENTS[950] = Fluid3D([12781,13001,13140,12140],0); -ELEMENTS[951] = Fluid3D([13716,12781,13140,13298],0); -ELEMENTS[952] = Fluid3D([12526,12502,12781,11863],0); -ELEMENTS[953] = Fluid3D([11281,11378,12140,12298],0); -ELEMENTS[954] = Fluid3D([12781,13101,13298,13716],0); -ELEMENTS[955] = Fluid3D([12526,13298,13189,12844],0); -ELEMENTS[956] = Fluid3D([12526,13298,12844,12591],0); -ELEMENTS[957] = Fluid3D([12140,12502,11863,12781],0); -ELEMENTS[958] = Fluid3D([12526,13298,12591,12781],0); -ELEMENTS[959] = Fluid3D([13298,13101,13189,13953],0); -ELEMENTS[960] = Fluid3D([13298,13101,13953,13716],0); -ELEMENTS[961] = Fluid3D([13101,13189,13953,13404],0); -ELEMENTS[962] = Fluid3D([13101,13189,13404,12425],0); -ELEMENTS[963] = Fluid3D([13189,12526,12844,12464],0); -ELEMENTS[964] = Fluid3D([13189,12526,12464,12425],0); -ELEMENTS[965] = Fluid3D([13953,13101,13404,14097],0); -ELEMENTS[966] = Fluid3D([12767,12425,13101,13404],0); -ELEMENTS[967] = Fluid3D([13298,12844,12591,13456],0); -ELEMENTS[968] = Fluid3D([12591,13298,13456,13484],0); -ELEMENTS[969] = Fluid3D([12591,13298,13484,13140],0); -ELEMENTS[970] = Fluid3D([13298,12844,13456,13917],0); -ELEMENTS[971] = Fluid3D([13298,12844,13917,13189],0); -ELEMENTS[972] = Fluid3D([12844,13189,12464,13249],0); -ELEMENTS[973] = Fluid3D([13189,12464,13249,12909],0); -ELEMENTS[974] = Fluid3D([12844,13189,13249,13917],0); -ELEMENTS[975] = Fluid3D([13249,13189,12909,13845],0); -ELEMENTS[976] = Fluid3D([13189,12464,12909,12425],0); -ELEMENTS[977] = Fluid3D([13189,13298,13953,13917],0); -ELEMENTS[978] = Fluid3D([12425,11640,12526,12464],0); -ELEMENTS[979] = Fluid3D([12844,12526,12591,11958],0); -ELEMENTS[980] = Fluid3D([12844,12526,11958,12464],0); -ELEMENTS[981] = Fluid3D([12526,12591,11958,11863],0); -ELEMENTS[982] = Fluid3D([11640,12425,11518,12464],0); -ELEMENTS[983] = Fluid3D([13189,13953,13404,13845],0); -ELEMENTS[984] = Fluid3D([13298,13456,13484,14157],0); -ELEMENTS[985] = Fluid3D([13456,12591,13484,13027],0); -ELEMENTS[986] = Fluid3D([12844,12591,13456,12612],0); -ELEMENTS[987] = Fluid3D([12844,12591,12612,11958],0); -ELEMENTS[988] = Fluid3D([13140,12611,13001,13261],0); -ELEMENTS[989] = Fluid3D([12781,13140,13298,12591],0); -ELEMENTS[990] = Fluid3D([12781,13140,12591,12184],0); -ELEMENTS[991] = Fluid3D([12781,13140,12184,12140],0); -ELEMENTS[992] = Fluid3D([12184,12781,12140,11863],0); -ELEMENTS[993] = Fluid3D([12140,12184,11863,10817],0); -ELEMENTS[994] = Fluid3D([12184,12781,11863,12591],0); -ELEMENTS[995] = Fluid3D([11863,12184,12591,11673],0); -ELEMENTS[996] = Fluid3D([11863,12184,11673,10817],0); -ELEMENTS[997] = Fluid3D([11643,12388,11909,11189],0); -ELEMENTS[998] = Fluid3D([12388,12442,11909,12723],0); -ELEMENTS[999] = Fluid3D([12388,12442,12723,13153],0); -ELEMENTS[1000] = Fluid3D([12442,11909,12723,13027],0); -ELEMENTS[1001] = Fluid3D([12723,12442,13027,13153],0); -ELEMENTS[1002] = Fluid3D([11909,12388,12723,11945],0); -ELEMENTS[1003] = Fluid3D([11909,12388,11945,11189],0); -ELEMENTS[1004] = Fluid3D([12723,11909,11945,12158],0); -ELEMENTS[1005] = Fluid3D([11909,11945,12158,11171],0); -ELEMENTS[1006] = Fluid3D([11945,12158,11171,11878],0); -ELEMENTS[1007] = Fluid3D([11909,11945,11171,11189],0); -ELEMENTS[1008] = Fluid3D([12723,11909,12158,13027],0); -ELEMENTS[1009] = Fluid3D([11945,12158,11878,12792],0); -ELEMENTS[1010] = Fluid3D([11945,12158,12792,12723],0); -ELEMENTS[1011] = Fluid3D([11878,11945,12792,12357],0); -ELEMENTS[1012] = Fluid3D([11945,12792,12357,12924],0); -ELEMENTS[1013] = Fluid3D([11945,12792,12924,12723],0); -ELEMENTS[1014] = Fluid3D([12158,11878,12792,12510],0); -ELEMENTS[1015] = Fluid3D([11878,12792,12510,12610],0); -ELEMENTS[1016] = Fluid3D([11878,12792,12610,12357],0); -ELEMENTS[1017] = Fluid3D([12158,11878,12510,11562],0); -ELEMENTS[1018] = Fluid3D([11878,12510,11562,11821],0); -ELEMENTS[1019] = Fluid3D([11878,11945,12357,11383],0); -ELEMENTS[1020] = Fluid3D([12158,11878,11562,11171],0); -ELEMENTS[1021] = Fluid3D([11878,12510,11821,12610],0); -ELEMENTS[1022] = Fluid3D([11878,11945,11383,11171],0); -ELEMENTS[1023] = Fluid3D([12510,12158,11562,12284],0); -ELEMENTS[1024] = Fluid3D([12510,12158,12284,13053],0); -ELEMENTS[1025] = Fluid3D([11562,12510,12284,12092],0); -ELEMENTS[1026] = Fluid3D([11562,12510,12092,11821],0); -ELEMENTS[1027] = Fluid3D([12158,11562,12284,11520],0); -ELEMENTS[1028] = Fluid3D([12284,12158,11520,12394],0); -ELEMENTS[1029] = Fluid3D([12284,12158,12394,13053],0); -ELEMENTS[1030] = Fluid3D([12158,11562,11520,11171],0); -ELEMENTS[1031] = Fluid3D([12510,12158,13053,12792],0); -ELEMENTS[1032] = Fluid3D([12510,12284,12092,13007],0); -ELEMENTS[1033] = Fluid3D([12092,12510,13007,12806],0); -ELEMENTS[1034] = Fluid3D([12510,12284,13007,13053],0); -ELEMENTS[1035] = Fluid3D([12284,12092,13007,12428],0); -ELEMENTS[1036] = Fluid3D([13007,12284,12428,13052],0); -ELEMENTS[1037] = Fluid3D([12284,12092,12428,11509],0); -ELEMENTS[1038] = Fluid3D([12510,13007,12806,13428],0); -ELEMENTS[1039] = Fluid3D([13007,12284,13052,13053],0); -ELEMENTS[1040] = Fluid3D([12284,12092,11509,11562],0); -ELEMENTS[1041] = Fluid3D([12510,13007,13428,13053],0); -ELEMENTS[1042] = Fluid3D([13007,12092,12806,12777],0); -ELEMENTS[1043] = Fluid3D([13007,12092,12777,12428],0); -ELEMENTS[1044] = Fluid3D([12806,13007,12777,13592],0); -ELEMENTS[1045] = Fluid3D([12092,12806,12777,12111],0); -ELEMENTS[1046] = Fluid3D([12092,12806,12111,11821],0); -ELEMENTS[1047] = Fluid3D([12777,12806,13592,13174],0); -ELEMENTS[1048] = Fluid3D([12777,12806,13174,12111],0); -ELEMENTS[1049] = Fluid3D([12806,13592,13174,13577],0); -ELEMENTS[1050] = Fluid3D([13592,13174,13577,14014],0); -ELEMENTS[1051] = Fluid3D([13592,13174,14014,13610],0); -ELEMENTS[1052] = Fluid3D([13592,13174,13610,12777],0); -ELEMENTS[1053] = Fluid3D([12806,13592,13577,13428],0); -ELEMENTS[1054] = Fluid3D([12806,13007,13592,13428],0); -ELEMENTS[1055] = Fluid3D([12092,12510,12806,11821],0); -ELEMENTS[1056] = Fluid3D([12777,12092,12111,11838],0); -ELEMENTS[1057] = Fluid3D([12092,12111,11838,11228],0); -ELEMENTS[1058] = Fluid3D([12111,11838,11228,11371],0); -ELEMENTS[1059] = Fluid3D([12111,11838,11371,12414],0); -ELEMENTS[1060] = Fluid3D([12111,12777,11838,12414],0); -ELEMENTS[1061] = Fluid3D([12777,12092,11838,12428],0); -ELEMENTS[1062] = Fluid3D([12092,12111,11228,11821],0); -ELEMENTS[1063] = Fluid3D([11838,11228,11371,10844],0); -ELEMENTS[1064] = Fluid3D([11838,11228,10844,11509],0); -ELEMENTS[1065] = Fluid3D([11371,11838,10844,11499],0); -ELEMENTS[1066] = Fluid3D([10844,11371,11499,10594],0); -ELEMENTS[1067] = Fluid3D([11228,11371,10844,10419],0); -ELEMENTS[1068] = Fluid3D([11371,11838,11499,12414],0); -ELEMENTS[1069] = Fluid3D([10844,11371,10594,10419],0); -ELEMENTS[1070] = Fluid3D([11228,11371,10419,11184],0); -ELEMENTS[1071] = Fluid3D([11228,11371,11184,12111],0); -ELEMENTS[1072] = Fluid3D([10419,11228,11184,10560],0); -ELEMENTS[1073] = Fluid3D([11184,10419,10560,10221],0); -ELEMENTS[1074] = Fluid3D([11184,10419,10221,10994],0); -ELEMENTS[1075] = Fluid3D([11184,10419,10994,11371],0); -ELEMENTS[1076] = Fluid3D([10419,11228,10560,10249],0); -ELEMENTS[1077] = Fluid3D([11228,10560,10249,10940],0); -ELEMENTS[1078] = Fluid3D([10560,10419,10249,9629],0); -ELEMENTS[1079] = Fluid3D([10419,11228,10249,10844],0); -ELEMENTS[1080] = Fluid3D([11228,10560,10940,11821],0); -ELEMENTS[1081] = Fluid3D([10249,10560,9629,9837],0); -ELEMENTS[1082] = Fluid3D([10249,10560,9837,10940],0); -ELEMENTS[1083] = Fluid3D([10560,9629,9837,9712],0); -ELEMENTS[1084] = Fluid3D([9629,9837,9712,8945],0); -ELEMENTS[1085] = Fluid3D([9837,9712,8945,9392],0); -ELEMENTS[1086] = Fluid3D([9837,9712,9392,10398],0); -ELEMENTS[1087] = Fluid3D([9837,9712,10398,10560],0); -ELEMENTS[1088] = Fluid3D([10560,9629,9712,10221],0); -ELEMENTS[1089] = Fluid3D([9629,9837,8945,8820],0); -ELEMENTS[1090] = Fluid3D([10560,10419,9629,10221],0); -ELEMENTS[1091] = Fluid3D([11838,10844,11499,11428],0); -ELEMENTS[1092] = Fluid3D([11838,10844,11428,11509],0); -ELEMENTS[1093] = Fluid3D([10844,11499,11428,10636],0); -ELEMENTS[1094] = Fluid3D([10844,11499,10636,10594],0); -ELEMENTS[1095] = Fluid3D([11499,11428,10636,11554],0); -ELEMENTS[1096] = Fluid3D([11499,11838,11428,12481],0); -ELEMENTS[1097] = Fluid3D([11428,11499,12481,11554],0); -ELEMENTS[1098] = Fluid3D([11428,10636,11554,10942],0); -ELEMENTS[1099] = Fluid3D([11428,10636,10942,10456],0); -ELEMENTS[1100] = Fluid3D([11428,10636,10456,10844],0); -ELEMENTS[1101] = Fluid3D([11554,11428,10942,11956],0); -ELEMENTS[1102] = Fluid3D([10942,11554,11956,11552],0); -ELEMENTS[1103] = Fluid3D([10942,11554,11552,10686],0); -ELEMENTS[1104] = Fluid3D([10942,11554,10686,10636],0); -ELEMENTS[1105] = Fluid3D([11554,11428,11956,12481],0); -ELEMENTS[1106] = Fluid3D([11499,11838,12481,12414],0); -ELEMENTS[1107] = Fluid3D([11371,11499,10594,11490],0); -ELEMENTS[1108] = Fluid3D([11371,11499,11490,12414],0); -ELEMENTS[1109] = Fluid3D([11499,10594,11490,11038],0); -ELEMENTS[1110] = Fluid3D([11499,10594,11038,10636],0); -ELEMENTS[1111] = Fluid3D([10594,11490,11038,10590],0); -ELEMENTS[1112] = Fluid3D([10594,11371,11490,10994],0); -ELEMENTS[1113] = Fluid3D([11038,10594,10590,9993],0); -ELEMENTS[1114] = Fluid3D([10594,10590,9993,9893],0); -ELEMENTS[1115] = Fluid3D([10594,10590,9893,10994],0); -ELEMENTS[1116] = Fluid3D([10594,11490,10590,10994],0); -ELEMENTS[1117] = Fluid3D([11038,10594,9993,10636],0); -ELEMENTS[1118] = Fluid3D([11490,11038,10590,11478],0); -ELEMENTS[1119] = Fluid3D([11490,11038,11478,12047],0); -ELEMENTS[1120] = Fluid3D([11038,10590,11478,10580],0); -ELEMENTS[1121] = Fluid3D([11038,11478,12047,11549],0); -ELEMENTS[1122] = Fluid3D([11038,11478,11549,10580],0); -ELEMENTS[1123] = Fluid3D([11038,10590,10580,9993],0); -ELEMENTS[1124] = Fluid3D([10590,11490,11478,11167],0); -ELEMENTS[1125] = Fluid3D([11490,11478,11167,12246],0); -ELEMENTS[1126] = Fluid3D([11478,10590,11167,10800],0); -ELEMENTS[1127] = Fluid3D([10590,11490,11167,10994],0); -ELEMENTS[1128] = Fluid3D([11478,10590,10800,10580],0); -ELEMENTS[1129] = Fluid3D([11490,11478,12246,12047],0); -ELEMENTS[1130] = Fluid3D([11490,11038,12047,11499],0); -ELEMENTS[1131] = Fluid3D([11428,10942,11956,11351],0); -ELEMENTS[1132] = Fluid3D([10942,11956,11351,11413],0); -ELEMENTS[1133] = Fluid3D([11956,11351,11413,12085],0); -ELEMENTS[1134] = Fluid3D([11956,11351,12085,12245],0); -ELEMENTS[1135] = Fluid3D([11428,10942,11351,10456],0); -ELEMENTS[1136] = Fluid3D([11351,12085,12245,11897],0); -ELEMENTS[1137] = Fluid3D([11351,12085,11897,11483],0); -ELEMENTS[1138] = Fluid3D([11351,12085,11483,11413],0); -ELEMENTS[1139] = Fluid3D([12245,11351,11897,11509],0); -ELEMENTS[1140] = Fluid3D([11956,11351,12245,11428],0); -ELEMENTS[1141] = Fluid3D([11351,10942,11413,10492],0); -ELEMENTS[1142] = Fluid3D([10942,11413,10492,10406],0); -ELEMENTS[1143] = Fluid3D([11351,10942,10492,10456],0); -ELEMENTS[1144] = Fluid3D([10492,10942,10406,9905],0); -ELEMENTS[1145] = Fluid3D([10942,10406,9905,10686],0); -ELEMENTS[1146] = Fluid3D([11413,11351,10492,11483],0); -ELEMENTS[1147] = Fluid3D([10492,10942,9905,10456],0); -ELEMENTS[1148] = Fluid3D([10942,11413,10406,11552],0); -ELEMENTS[1149] = Fluid3D([10942,11956,11413,11552],0); -ELEMENTS[1150] = Fluid3D([11413,10492,10406,10724],0); -ELEMENTS[1151] = Fluid3D([11413,10492,10724,11483],0); -ELEMENTS[1152] = Fluid3D([10406,11413,10724,11311],0); -ELEMENTS[1153] = Fluid3D([10492,10406,10724,9762],0); -ELEMENTS[1154] = Fluid3D([10492,10406,9762,9905],0); -ELEMENTS[1155] = Fluid3D([10724,10406,11311,10305],0); -ELEMENTS[1156] = Fluid3D([10724,10406,10305,9762],0); -ELEMENTS[1157] = Fluid3D([11311,10724,10305,11012],0); -ELEMENTS[1158] = Fluid3D([10305,11311,11012,11048],0); -ELEMENTS[1159] = Fluid3D([10305,11311,11048,10773],0); -ELEMENTS[1160] = Fluid3D([10305,11311,10773,10406],0); -ELEMENTS[1161] = Fluid3D([10406,11413,11311,11552],0); -ELEMENTS[1162] = Fluid3D([11311,10724,11012,11710],0); -ELEMENTS[1163] = Fluid3D([10724,11012,11710,10993],0); -ELEMENTS[1164] = Fluid3D([11311,10724,11710,11413],0); -ELEMENTS[1165] = Fluid3D([11012,11710,10993,11748],0); -ELEMENTS[1166] = Fluid3D([11012,11710,11748,11986],0); -ELEMENTS[1167] = Fluid3D([11012,11710,11986,11311],0); -ELEMENTS[1168] = Fluid3D([10993,11012,11748,10809],0); -ELEMENTS[1169] = Fluid3D([10993,11012,10809,10087],0); -ELEMENTS[1170] = Fluid3D([10993,11012,10087,10724],0); -ELEMENTS[1171] = Fluid3D([11748,10993,10809,11380],0); -ELEMENTS[1172] = Fluid3D([10809,11748,11380,11636],0); -ELEMENTS[1173] = Fluid3D([10809,11748,11636,11439],0); -ELEMENTS[1174] = Fluid3D([10809,11748,11439,11012],0); -ELEMENTS[1175] = Fluid3D([11748,10993,11380,11943],0); -ELEMENTS[1176] = Fluid3D([11748,10993,11943,11710],0); -ELEMENTS[1177] = Fluid3D([11380,11748,11943,12359],0); -ELEMENTS[1178] = Fluid3D([11748,11943,12359,12644],0); -ELEMENTS[1179] = Fluid3D([11748,11943,12644,11710],0); -ELEMENTS[1180] = Fluid3D([11380,11748,12359,11636],0); -ELEMENTS[1181] = Fluid3D([10993,11380,11943,10946],0); -ELEMENTS[1182] = Fluid3D([11380,11943,10946,11974],0); -ELEMENTS[1183] = Fluid3D([11943,10993,10946,11483],0); -ELEMENTS[1184] = Fluid3D([10993,11380,10946,10228],0); -ELEMENTS[1185] = Fluid3D([11380,10946,10228,10754],0); -ELEMENTS[1186] = Fluid3D([11380,10946,10754,11974],0); -ELEMENTS[1187] = Fluid3D([10993,11380,10228,10809],0); -ELEMENTS[1188] = Fluid3D([11380,11943,11974,12359],0); -ELEMENTS[1189] = Fluid3D([10724,10305,11012,10087],0); -ELEMENTS[1190] = Fluid3D([11943,10946,11974,12002],0); -ELEMENTS[1191] = Fluid3D([11943,10946,12002,11483],0); -ELEMENTS[1192] = Fluid3D([11974,11943,12002,12755],0); -ELEMENTS[1193] = Fluid3D([11974,11943,12755,12359],0); -ELEMENTS[1194] = Fluid3D([12002,11974,12755,12540],0); -ELEMENTS[1195] = Fluid3D([11974,12755,12540,12886],0); -ELEMENTS[1196] = Fluid3D([12755,12540,12886,13382],0); -ELEMENTS[1197] = Fluid3D([12755,12540,13382,12998],0); -ELEMENTS[1198] = Fluid3D([12755,12540,12998,12002],0); -ELEMENTS[1199] = Fluid3D([10946,11974,12002,11479],0); -ELEMENTS[1200] = Fluid3D([11974,12002,11479,12540],0); -ELEMENTS[1201] = Fluid3D([10946,11974,11479,10754],0); -ELEMENTS[1202] = Fluid3D([11974,12755,12886,12359],0); -ELEMENTS[1203] = Fluid3D([11943,12002,12755,12496],0); -ELEMENTS[1204] = Fluid3D([12755,11943,12496,12644],0); -ELEMENTS[1205] = Fluid3D([11943,12002,12496,11483],0); -ELEMENTS[1206] = Fluid3D([12002,12755,12496,12998],0); -ELEMENTS[1207] = Fluid3D([12540,12886,13382,13088],0); -ELEMENTS[1208] = Fluid3D([13382,12540,13088,13249],0); -ELEMENTS[1209] = Fluid3D([12886,13382,13088,13737],0); -ELEMENTS[1210] = Fluid3D([13382,13088,13737,13995],0); -ELEMENTS[1211] = Fluid3D([13088,13737,13995,13842],0); -ELEMENTS[1212] = Fluid3D([13088,13737,13842,13136],0); -ELEMENTS[1213] = Fluid3D([13088,13737,13136,12886],0); -ELEMENTS[1214] = Fluid3D([12540,12886,13088,12258],0); -ELEMENTS[1215] = Fluid3D([12540,12886,12258,11974],0); -ELEMENTS[1216] = Fluid3D([12886,13088,12258,13136],0); -ELEMENTS[1217] = Fluid3D([13382,13088,13995,13457],0); -ELEMENTS[1218] = Fluid3D([13382,13088,13457,13249],0); -ELEMENTS[1219] = Fluid3D([13088,13995,13457,13667],0); -ELEMENTS[1220] = Fluid3D([13088,13995,13667,13842],0); -ELEMENTS[1221] = Fluid3D([13457,13088,13667,12909],0); -ELEMENTS[1222] = Fluid3D([13667,13457,12909,13845],0); -ELEMENTS[1223] = Fluid3D([13457,12909,13845,13249],0); -ELEMENTS[1224] = Fluid3D([13845,13457,13249,13891],0); -ELEMENTS[1225] = Fluid3D([13457,13249,13891,13382],0); -ELEMENTS[1226] = Fluid3D([13457,12909,13249,13088],0); -ELEMENTS[1227] = Fluid3D([13845,13457,13891,13995],0); -ELEMENTS[1228] = Fluid3D([13667,13457,13845,13995],0); -ELEMENTS[1229] = Fluid3D([12909,13667,13845,13404],0); -ELEMENTS[1230] = Fluid3D([13249,13845,13891,13917],0); -ELEMENTS[1231] = Fluid3D([13891,13457,13382,13995],0); -ELEMENTS[1232] = Fluid3D([12886,13382,13737,13557],0); -ELEMENTS[1233] = Fluid3D([12886,13382,13557,12755],0); -ELEMENTS[1234] = Fluid3D([13737,12886,13557,13322],0); -ELEMENTS[1235] = Fluid3D([13557,13737,13322,14186],0); -ELEMENTS[1236] = Fluid3D([13557,13737,14186,14293],0); -ELEMENTS[1237] = Fluid3D([14186,13557,14293,14290],0); -ELEMENTS[1238] = Fluid3D([14186,13557,14290,13623],0); -ELEMENTS[1239] = Fluid3D([14186,13557,13623,13322],0); -ELEMENTS[1240] = Fluid3D([13557,13737,14293,13382],0); -ELEMENTS[1241] = Fluid3D([13737,12886,13322,13136],0); -ELEMENTS[1242] = Fluid3D([13737,13382,13995,14293],0); -ELEMENTS[1243] = Fluid3D([13088,12540,12258,12429],0); -ELEMENTS[1244] = Fluid3D([12540,12258,12429,11479],0); -ELEMENTS[1245] = Fluid3D([12258,13088,12429,12754],0); -ELEMENTS[1246] = Fluid3D([12258,13088,12754,13136],0); -ELEMENTS[1247] = Fluid3D([13088,12429,12754,13667],0); -ELEMENTS[1248] = Fluid3D([13088,12540,12429,12909],0); -ELEMENTS[1249] = Fluid3D([12429,13088,12909,13667],0); -ELEMENTS[1250] = Fluid3D([12909,12429,13667,12826],0); -ELEMENTS[1251] = Fluid3D([12909,12429,12826,12071],0); -ELEMENTS[1252] = Fluid3D([12909,12429,12071,12464],0); -ELEMENTS[1253] = Fluid3D([12826,12909,12071,12425],0); -ELEMENTS[1254] = Fluid3D([12071,12909,12464,12425],0); -ELEMENTS[1255] = Fluid3D([12429,12826,12071,12043],0); -ELEMENTS[1256] = Fluid3D([12071,12429,12043,11496],0); -ELEMENTS[1257] = Fluid3D([12071,12429,11496,12464],0); -ELEMENTS[1258] = Fluid3D([12429,12043,11496,12258],0); -ELEMENTS[1259] = Fluid3D([12043,12071,11496,11145],0); -ELEMENTS[1260] = Fluid3D([12071,11496,11145,11258],0); -ELEMENTS[1261] = Fluid3D([12071,11496,11258,12464],0); -ELEMENTS[1262] = Fluid3D([12043,12071,11145,11948],0); -ELEMENTS[1263] = Fluid3D([11145,12071,11258,11518],0); -ELEMENTS[1264] = Fluid3D([11145,12071,11518,11948],0); -ELEMENTS[1265] = Fluid3D([11518,11145,11948,10851],0); -ELEMENTS[1266] = Fluid3D([11518,11145,10851,11258],0); -ELEMENTS[1267] = Fluid3D([12071,11518,11948,12425],0); -ELEMENTS[1268] = Fluid3D([12071,11518,12425,12464],0); -ELEMENTS[1269] = Fluid3D([11948,11518,10851,11932],0); -ELEMENTS[1270] = Fluid3D([12071,11258,11518,12464],0); -ELEMENTS[1271] = Fluid3D([10851,11518,11258,10825],0); -ELEMENTS[1272] = Fluid3D([12043,12071,11948,12826],0); -ELEMENTS[1273] = Fluid3D([11496,11145,11258,10494],0); -ELEMENTS[1274] = Fluid3D([11258,11496,10494,11033],0); -ELEMENTS[1275] = Fluid3D([11496,11145,10494,10862],0); -ELEMENTS[1276] = Fluid3D([11258,11496,11033,12464],0); -ELEMENTS[1277] = Fluid3D([11145,12043,11948,10874],0); -ELEMENTS[1278] = Fluid3D([11496,10494,11033,11479],0); -ELEMENTS[1279] = Fluid3D([11033,11496,11479,12026],0); -ELEMENTS[1280] = Fluid3D([11479,11033,12026,12002],0); -ELEMENTS[1281] = Fluid3D([11496,11479,12026,12429],0); -ELEMENTS[1282] = Fluid3D([11033,11496,12026,12464],0); -ELEMENTS[1283] = Fluid3D([11496,12043,11145,10862],0); -ELEMENTS[1284] = Fluid3D([13667,12909,12826,13404],0); -ELEMENTS[1285] = Fluid3D([11145,11258,10494,10851],0); -ELEMENTS[1286] = Fluid3D([12429,12826,12043,12754],0); -ELEMENTS[1287] = Fluid3D([12429,12258,12754,12043],0); -ELEMENTS[1288] = Fluid3D([12334,12388,12641,13153],0); -ELEMENTS[1289] = Fluid3D([12002,10946,11479,11033],0); -ELEMENTS[1290] = Fluid3D([12388,12723,11945,12924],0); -ELEMENTS[1291] = Fluid3D([11167,11490,12246,11884],0); -ELEMENTS[1292] = Fluid3D([12246,11167,11884,12199],0); -ELEMENTS[1293] = Fluid3D([11167,11490,11884,10994],0); -ELEMENTS[1294] = Fluid3D([11167,11884,12199,11406],0); -ELEMENTS[1295] = Fluid3D([12199,11167,11406,11393],0); -ELEMENTS[1296] = Fluid3D([11406,12199,11393,12010],0); -ELEMENTS[1297] = Fluid3D([11406,12199,12010,12280],0); -ELEMENTS[1298] = Fluid3D([11406,12199,12280,11884],0); -ELEMENTS[1299] = Fluid3D([11167,11884,11406,10994],0); -ELEMENTS[1300] = Fluid3D([12199,11167,11393,11887],0); -ELEMENTS[1301] = Fluid3D([12199,11167,11887,12246],0); -ELEMENTS[1302] = Fluid3D([11167,11393,11887,10800],0); -ELEMENTS[1303] = Fluid3D([11393,12199,11887,12312],0); -ELEMENTS[1304] = Fluid3D([12199,11887,12312,12850],0); -ELEMENTS[1305] = Fluid3D([11393,12199,12312,12010],0); -ELEMENTS[1306] = Fluid3D([11887,12312,12850,12517],0); -ELEMENTS[1307] = Fluid3D([11887,12312,12517,11620],0); -ELEMENTS[1308] = Fluid3D([11887,12312,11620,11393],0); -ELEMENTS[1309] = Fluid3D([12312,12850,12517,13194],0); -ELEMENTS[1310] = Fluid3D([12517,12312,13194,12519],0); -ELEMENTS[1311] = Fluid3D([12312,12850,13194,13098],0); -ELEMENTS[1312] = Fluid3D([12517,12312,12519,11620],0); -ELEMENTS[1313] = Fluid3D([12312,12850,13098,12199],0); -ELEMENTS[1314] = Fluid3D([12199,11887,12850,12246],0); -ELEMENTS[1315] = Fluid3D([12850,12517,13194,13387],0); -ELEMENTS[1316] = Fluid3D([12517,13194,13387,13244],0); -ELEMENTS[1317] = Fluid3D([13194,13387,13244,13978],0); -ELEMENTS[1318] = Fluid3D([13194,13387,13978,13823],0); -ELEMENTS[1319] = Fluid3D([13194,13387,13823,12850],0); -ELEMENTS[1320] = Fluid3D([12850,12517,13387,12658],0); -ELEMENTS[1321] = Fluid3D([12517,13387,12658,12880],0); -ELEMENTS[1322] = Fluid3D([12517,13387,12880,13244],0); -ELEMENTS[1323] = Fluid3D([12850,12517,12658,11887],0); -ELEMENTS[1324] = Fluid3D([12517,13194,13244,12519],0); -ELEMENTS[1325] = Fluid3D([13387,13978,13823,14244],0); -ELEMENTS[1326] = Fluid3D([13387,13978,14244,13947],0); -ELEMENTS[1327] = Fluid3D([13823,13387,14244,13664],0); -ELEMENTS[1328] = Fluid3D([13823,13387,13664,12850],0); -ELEMENTS[1329] = Fluid3D([13978,13823,14244,14607],0); -ELEMENTS[1330] = Fluid3D([13823,14244,14607,14466],0); -ELEMENTS[1331] = Fluid3D([13978,13823,14607,13952],0); -ELEMENTS[1332] = Fluid3D([13978,13823,13952,13194],0); -ELEMENTS[1333] = Fluid3D([13823,14244,14466,13664],0); -ELEMENTS[1334] = Fluid3D([13387,14244,13664,13741],0); -ELEMENTS[1335] = Fluid3D([13387,14244,13741,13947],0); -ELEMENTS[1336] = Fluid3D([13664,13387,13741,12658],0); -ELEMENTS[1337] = Fluid3D([13387,13978,13947,13244],0); -ELEMENTS[1338] = Fluid3D([13387,12850,12658,13664],0); -ELEMENTS[1339] = Fluid3D([13978,14244,13947,14692],0); -ELEMENTS[1340] = Fluid3D([14244,13947,14692,14603],0); -ELEMENTS[1341] = Fluid3D([14692,14244,14603,15034],0); -ELEMENTS[1342] = Fluid3D([13978,14244,14692,14607],0); -ELEMENTS[1343] = Fluid3D([13947,13978,14692,14194],0); -ELEMENTS[1344] = Fluid3D([13947,13978,14194,13244],0); -ELEMENTS[1345] = Fluid3D([13978,14692,14194,14631],0); -ELEMENTS[1346] = Fluid3D([13978,14692,14631,14607],0); -ELEMENTS[1347] = Fluid3D([14692,14194,14631,14981],0); -ELEMENTS[1348] = Fluid3D([14692,14194,14981,14642],0); -ELEMENTS[1349] = Fluid3D([14692,14194,14642,13947],0); -ELEMENTS[1350] = Fluid3D([14194,14631,14981,14529],0); -ELEMENTS[1351] = Fluid3D([14194,14631,14529,13749],0); -ELEMENTS[1352] = Fluid3D([14194,14631,13749,13978],0); -ELEMENTS[1353] = Fluid3D([14981,14194,14529,14528],0); -ELEMENTS[1354] = Fluid3D([14529,14981,14528,15156],0); -ELEMENTS[1355] = Fluid3D([14981,14194,14528,14642],0); -ELEMENTS[1356] = Fluid3D([14529,14981,15156,15239],0); -ELEMENTS[1357] = Fluid3D([15156,14529,15239,15030],0); -ELEMENTS[1358] = Fluid3D([15156,14529,15030,14539],0); -ELEMENTS[1359] = Fluid3D([15156,14529,14539,14528],0); -ELEMENTS[1360] = Fluid3D([14529,14981,15239,14631],0); -ELEMENTS[1361] = Fluid3D([14244,13947,14603,13741],0); -ELEMENTS[1362] = Fluid3D([14692,14244,15034,14607],0); -ELEMENTS[1363] = Fluid3D([14631,14692,14981,15292],0); -ELEMENTS[1364] = Fluid3D([14631,14692,15292,14607],0); -ELEMENTS[1365] = Fluid3D([14692,14981,15292,15343],0); -ELEMENTS[1366] = Fluid3D([15292,14692,15343,15034],0); -ELEMENTS[1367] = Fluid3D([14692,14981,15343,14642],0); -ELEMENTS[1368] = Fluid3D([14981,15292,15343,15676],0); -ELEMENTS[1369] = Fluid3D([15292,15343,15676,15851],0); -ELEMENTS[1370] = Fluid3D([15343,14981,15676,15396],0); -ELEMENTS[1371] = Fluid3D([14981,15292,15676,15239],0); -ELEMENTS[1372] = Fluid3D([15343,14981,15396,14642],0); -ELEMENTS[1373] = Fluid3D([15292,15343,15851,15034],0); -ELEMENTS[1374] = Fluid3D([14981,15676,15396,15156],0); -ELEMENTS[1375] = Fluid3D([14981,14631,15292,15239],0); -ELEMENTS[1376] = Fluid3D([14244,14603,15034,14593],0); -ELEMENTS[1377] = Fluid3D([15034,14244,14593,14466],0); -ELEMENTS[1378] = Fluid3D([14244,14603,14593,13741],0); -ELEMENTS[1379] = Fluid3D([14603,15034,14593,15215],0); -ELEMENTS[1380] = Fluid3D([15034,14593,15215,15289],0); -ELEMENTS[1381] = Fluid3D([14593,14603,15215,14581],0); -ELEMENTS[1382] = Fluid3D([14603,15034,15215,15343],0); -ELEMENTS[1383] = Fluid3D([14593,15215,15289,15053],0); -ELEMENTS[1384] = Fluid3D([15215,15289,15053,15713],0); -ELEMENTS[1385] = Fluid3D([15215,15289,15713,15742],0); -ELEMENTS[1386] = Fluid3D([14593,15215,15053,14581],0); -ELEMENTS[1387] = Fluid3D([15215,15289,15742,15034],0); -ELEMENTS[1388] = Fluid3D([14593,14603,14581,13741],0); -ELEMENTS[1389] = Fluid3D([15034,14593,15289,14466],0); -ELEMENTS[1390] = Fluid3D([14603,15215,14581,15011],0); -ELEMENTS[1391] = Fluid3D([14603,15215,15011,15343],0); -ELEMENTS[1392] = Fluid3D([15215,14581,15011,15275],0); -ELEMENTS[1393] = Fluid3D([15215,14581,15275,15053],0); -ELEMENTS[1394] = Fluid3D([15011,15215,15275,15690],0); -ELEMENTS[1395] = Fluid3D([15215,15275,15690,15713],0); -ELEMENTS[1396] = Fluid3D([15011,15215,15690,15343],0); -ELEMENTS[1397] = Fluid3D([14581,15011,15275,14716],0); -ELEMENTS[1398] = Fluid3D([15275,14581,14716,14717],0); -ELEMENTS[1399] = Fluid3D([14581,15011,14716,14234],0); -ELEMENTS[1400] = Fluid3D([15011,15275,14716,15405],0); -ELEMENTS[1401] = Fluid3D([15011,15275,15405,15690],0); -ELEMENTS[1402] = Fluid3D([14581,15011,14234,14603],0); -ELEMENTS[1403] = Fluid3D([15275,14581,14717,15053],0); -ELEMENTS[1404] = Fluid3D([14716,15275,14717,15212],0); -ELEMENTS[1405] = Fluid3D([15275,14717,15212,15410],0); -ELEMENTS[1406] = Fluid3D([14717,15212,15410,14970],0); -ELEMENTS[1407] = Fluid3D([14717,15212,14970,14476],0); -ELEMENTS[1408] = Fluid3D([14717,15212,14476,14716],0); -ELEMENTS[1409] = Fluid3D([14716,15275,15212,15405],0); -ELEMENTS[1410] = Fluid3D([15275,14717,15410,15053],0); -ELEMENTS[1411] = Fluid3D([15212,15410,14970,15635],0); -ELEMENTS[1412] = Fluid3D([15410,14970,15635,15478],0); -ELEMENTS[1413] = Fluid3D([14970,15635,15478,15353],0); -ELEMENTS[1414] = Fluid3D([14970,15635,15353,15169],0); -ELEMENTS[1415] = Fluid3D([14970,15635,15169,15212],0); -ELEMENTS[1416] = Fluid3D([15212,15410,15635,15838],0); -ELEMENTS[1417] = Fluid3D([15410,15635,15838,16029],0); -ELEMENTS[1418] = Fluid3D([15410,15635,16029,15478],0); -ELEMENTS[1419] = Fluid3D([15212,15410,15838,15275],0); -ELEMENTS[1420] = Fluid3D([15410,14970,15478,14926],0); -ELEMENTS[1421] = Fluid3D([15478,15410,14926,15569],0); -ELEMENTS[1422] = Fluid3D([15410,14970,14926,14717],0); -ELEMENTS[1423] = Fluid3D([14970,15478,14926,14849],0); -ELEMENTS[1424] = Fluid3D([14926,14970,14849,14262],0); -ELEMENTS[1425] = Fluid3D([14926,14970,14262,14717],0); -ELEMENTS[1426] = Fluid3D([14970,15478,14849,15353],0); -ELEMENTS[1427] = Fluid3D([15410,14926,15569,15053],0); -ELEMENTS[1428] = Fluid3D([15478,15410,15569,16029],0); -ELEMENTS[1429] = Fluid3D([15635,15212,15838,15733],0); -ELEMENTS[1430] = Fluid3D([15212,15838,15733,15405],0); -ELEMENTS[1431] = Fluid3D([15635,15212,15733,15169],0); -ELEMENTS[1432] = Fluid3D([15838,15635,15733,16214],0); -ELEMENTS[1433] = Fluid3D([15838,15635,16214,16029],0); -ELEMENTS[1434] = Fluid3D([15635,15733,16214,15904],0); -ELEMENTS[1435] = Fluid3D([16214,15635,15904,16251],0); -ELEMENTS[1436] = Fluid3D([16214,15635,16251,16029],0); -ELEMENTS[1437] = Fluid3D([15635,15733,15904,15169],0); -ELEMENTS[1438] = Fluid3D([15733,15838,16214,16208],0); -ELEMENTS[1439] = Fluid3D([15733,15838,16208,15405],0); -ELEMENTS[1440] = Fluid3D([16214,15733,16208,16271],0); -ELEMENTS[1441] = Fluid3D([15838,16214,16208,16422],0); -ELEMENTS[1442] = Fluid3D([15838,16214,16422,16029],0); -ELEMENTS[1443] = Fluid3D([16214,15733,16271,15904],0); -ELEMENTS[1444] = Fluid3D([15635,15904,16251,15353],0); -ELEMENTS[1445] = Fluid3D([15733,16208,16271,15945],0); -ELEMENTS[1446] = Fluid3D([15733,16208,15945,15405],0); -ELEMENTS[1447] = Fluid3D([16208,16271,15945,16511],0); -ELEMENTS[1448] = Fluid3D([15945,16208,16511,16191],0); -ELEMENTS[1449] = Fluid3D([15945,16208,16191,15405],0); -ELEMENTS[1450] = Fluid3D([16208,16271,16511,16691],0); -ELEMENTS[1451] = Fluid3D([16271,16511,16691,16859],0); -ELEMENTS[1452] = Fluid3D([16208,16271,16691,16214],0); -ELEMENTS[1453] = Fluid3D([16271,16511,16859,16415],0); -ELEMENTS[1454] = Fluid3D([16511,16859,16415,16810],0); -ELEMENTS[1455] = Fluid3D([16511,16859,16810,17003],0); -ELEMENTS[1456] = Fluid3D([16511,16859,17003,16691],0); -ELEMENTS[1457] = Fluid3D([16271,16511,16415,15945],0); -ELEMENTS[1458] = Fluid3D([16271,15733,15945,15706],0); -ELEMENTS[1459] = Fluid3D([15945,16271,15706,16415],0); -ELEMENTS[1460] = Fluid3D([15733,15945,15706,15300],0); -ELEMENTS[1461] = Fluid3D([15945,15706,15300,15827],0); -ELEMENTS[1462] = Fluid3D([15945,15706,15827,16415],0); -ELEMENTS[1463] = Fluid3D([16271,15733,15706,15904],0); -ELEMENTS[1464] = Fluid3D([15706,15300,15827,15153],0); -ELEMENTS[1465] = Fluid3D([15706,15300,15153,15169],0); -ELEMENTS[1466] = Fluid3D([15300,15827,15153,14818],0); -ELEMENTS[1467] = Fluid3D([15300,15827,14818,15465],0); -ELEMENTS[1468] = Fluid3D([15300,15827,15465,15945],0); -ELEMENTS[1469] = Fluid3D([15827,15706,15153,15801],0); -ELEMENTS[1470] = Fluid3D([15153,15827,15801,15245],0); -ELEMENTS[1471] = Fluid3D([15153,15827,15245,14818],0); -ELEMENTS[1472] = Fluid3D([15827,15706,15801,16415],0); -ELEMENTS[1473] = Fluid3D([15733,15945,15300,15405],0); -ELEMENTS[1474] = Fluid3D([16208,16511,16191,16649],0); -ELEMENTS[1475] = Fluid3D([16208,16511,16649,16691],0); -ELEMENTS[1476] = Fluid3D([16511,16191,16649,16695],0); -ELEMENTS[1477] = Fluid3D([16649,16511,16695,17003],0); -ELEMENTS[1478] = Fluid3D([16511,16191,16695,16320],0); -ELEMENTS[1479] = Fluid3D([16191,16695,16320,16290],0); -ELEMENTS[1480] = Fluid3D([16191,16695,16290,16493],0); -ELEMENTS[1481] = Fluid3D([16191,16695,16493,16649],0); -ELEMENTS[1482] = Fluid3D([16511,16191,16320,15945],0); -ELEMENTS[1483] = Fluid3D([16695,16511,16320,16810],0); -ELEMENTS[1484] = Fluid3D([16191,16208,16649,16190],0); -ELEMENTS[1485] = Fluid3D([16208,16649,16190,16422],0); -ELEMENTS[1486] = Fluid3D([16191,16208,16190,15405],0); -ELEMENTS[1487] = Fluid3D([16649,16191,16190,16493],0); -ELEMENTS[1488] = Fluid3D([14926,15478,15569,15269],0); -ELEMENTS[1489] = Fluid3D([14926,15478,15269,14849],0); -ELEMENTS[1490] = Fluid3D([15569,14926,15269,15023],0); -ELEMENTS[1491] = Fluid3D([15569,14926,15023,15053],0); -ELEMENTS[1492] = Fluid3D([15269,15569,15023,15638],0); -ELEMENTS[1493] = Fluid3D([15569,15023,15638,15578],0); -ELEMENTS[1494] = Fluid3D([15569,15023,15578,15053],0); -ELEMENTS[1495] = Fluid3D([15478,15569,15269,15914],0); -ELEMENTS[1496] = Fluid3D([15569,15269,15914,15638],0); -ELEMENTS[1497] = Fluid3D([15478,15569,15914,16029],0); -ELEMENTS[1498] = Fluid3D([14926,15269,15023,14504],0); -ELEMENTS[1499] = Fluid3D([14926,15269,14504,14849],0); -ELEMENTS[1500] = Fluid3D([15023,14926,14504,14338],0); -ELEMENTS[1501] = Fluid3D([15269,15023,14504,14868],0); -ELEMENTS[1502] = Fluid3D([14926,14504,14338,14262],0); -ELEMENTS[1503] = Fluid3D([15269,15023,14868,15638],0); -ELEMENTS[1504] = Fluid3D([14504,15023,14338,14332],0); -ELEMENTS[1505] = Fluid3D([14338,14504,14332,13721],0); -ELEMENTS[1506] = Fluid3D([14504,15023,14332,14868],0); -ELEMENTS[1507] = Fluid3D([15023,14338,14332,14596],0); -ELEMENTS[1508] = Fluid3D([15023,14338,14596,15053],0); -ELEMENTS[1509] = Fluid3D([14332,15023,14596,14997],0); -ELEMENTS[1510] = Fluid3D([14332,15023,14997,14868],0); -ELEMENTS[1511] = Fluid3D([15023,14596,14997,15578],0); -ELEMENTS[1512] = Fluid3D([14338,14504,13721,14262],0); -ELEMENTS[1513] = Fluid3D([14504,14332,13721,14058],0); -ELEMENTS[1514] = Fluid3D([14504,14332,14058,14868],0); -ELEMENTS[1515] = Fluid3D([13721,14504,14058,13863],0); -ELEMENTS[1516] = Fluid3D([14504,14058,13863,14564],0); -ELEMENTS[1517] = Fluid3D([14504,14058,14564,14868],0); -ELEMENTS[1518] = Fluid3D([14332,13721,14058,13376],0); -ELEMENTS[1519] = Fluid3D([14058,14332,13376,14159],0); -ELEMENTS[1520] = Fluid3D([14058,14332,14159,14868],0); -ELEMENTS[1521] = Fluid3D([13721,14058,13376,13180],0); -ELEMENTS[1522] = Fluid3D([13721,14058,13180,13863],0); -ELEMENTS[1523] = Fluid3D([14058,13376,13180,13511],0); -ELEMENTS[1524] = Fluid3D([14332,13721,13376,13693],0); -ELEMENTS[1525] = Fluid3D([13180,14058,13511,13626],0); -ELEMENTS[1526] = Fluid3D([13180,14058,13626,13863],0); -ELEMENTS[1527] = Fluid3D([14058,13376,13511,14159],0); -ELEMENTS[1528] = Fluid3D([14332,13721,13693,14338],0); -ELEMENTS[1529] = Fluid3D([13376,13180,13511,12728],0); -ELEMENTS[1530] = Fluid3D([13376,13180,12728,12824],0); -ELEMENTS[1531] = Fluid3D([13180,12728,12824,12239],0); -ELEMENTS[1532] = Fluid3D([13180,12728,12239,12633],0); -ELEMENTS[1533] = Fluid3D([13180,12728,12633,13511],0); -ELEMENTS[1534] = Fluid3D([13511,13376,12728,13349],0); -ELEMENTS[1535] = Fluid3D([13376,12728,13349,12481],0); -ELEMENTS[1536] = Fluid3D([13511,13376,13349,14159],0); -ELEMENTS[1537] = Fluid3D([12728,13511,13349,12943],0); -ELEMENTS[1538] = Fluid3D([13349,12728,12943,12245],0); -ELEMENTS[1539] = Fluid3D([13511,13349,12943,13720],0); -ELEMENTS[1540] = Fluid3D([13349,12943,13720,12977],0); -ELEMENTS[1541] = Fluid3D([13511,13349,13720,14159],0); -ELEMENTS[1542] = Fluid3D([12728,13511,12943,12633],0); -ELEMENTS[1543] = Fluid3D([13349,12943,12977,12245],0); -ELEMENTS[1544] = Fluid3D([13721,14504,13863,14262],0); -ELEMENTS[1545] = Fluid3D([13376,13180,12824,13721],0); -ELEMENTS[1546] = Fluid3D([15023,14926,14338,15053],0); -ELEMENTS[1547] = Fluid3D([15638,15569,15578,16112],0); -ELEMENTS[1548] = Fluid3D([15638,15569,16112,15914],0); -ELEMENTS[1549] = Fluid3D([15569,15578,16112,15881],0); -ELEMENTS[1550] = Fluid3D([16112,15569,15881,16029],0); -ELEMENTS[1551] = Fluid3D([15569,15578,15881,15053],0); -ELEMENTS[1552] = Fluid3D([15578,16112,15881,16148],0); -ELEMENTS[1553] = Fluid3D([15578,16112,16148,16025],0); -ELEMENTS[1554] = Fluid3D([16112,15881,16148,16452],0); -ELEMENTS[1555] = Fluid3D([16112,15881,16452,16029],0); -ELEMENTS[1556] = Fluid3D([15881,15578,16148,15564],0); -ELEMENTS[1557] = Fluid3D([15578,16148,15564,15701],0); -ELEMENTS[1558] = Fluid3D([15881,15578,15564,15053],0); -ELEMENTS[1559] = Fluid3D([15578,16148,15701,16025],0); -ELEMENTS[1560] = Fluid3D([15881,16148,16452,16228],0); -ELEMENTS[1561] = Fluid3D([15881,16148,16228,15564],0); -ELEMENTS[1562] = Fluid3D([16148,16452,16228,16636],0); -ELEMENTS[1563] = Fluid3D([16452,16228,16636,16728],0); -ELEMENTS[1564] = Fluid3D([16228,16636,16728,16616],0); -ELEMENTS[1565] = Fluid3D([16228,16636,16616,16263],0); -ELEMENTS[1566] = Fluid3D([16228,16636,16263,16148],0); -ELEMENTS[1567] = Fluid3D([16148,16452,16636,16597],0); -ELEMENTS[1568] = Fluid3D([16148,16452,16597,16112],0); -ELEMENTS[1569] = Fluid3D([16636,16148,16597,16544],0); -ELEMENTS[1570] = Fluid3D([16148,16597,16544,16025],0); -ELEMENTS[1571] = Fluid3D([16636,16148,16544,16263],0); -ELEMENTS[1572] = Fluid3D([16452,16228,16728,16339],0); -ELEMENTS[1573] = Fluid3D([16228,16728,16339,16463],0); -ELEMENTS[1574] = Fluid3D([16728,16452,16339,16760],0); -ELEMENTS[1575] = Fluid3D([16728,16452,16760,16969],0); -ELEMENTS[1576] = Fluid3D([16728,16452,16969,16636],0); -ELEMENTS[1577] = Fluid3D([16452,16228,16339,15881],0); -ELEMENTS[1578] = Fluid3D([16228,16728,16463,16616],0); -ELEMENTS[1579] = Fluid3D([15578,15638,16112,16025],0); -ELEMENTS[1580] = Fluid3D([16112,16148,16025,16597],0); -ELEMENTS[1581] = Fluid3D([11490,12246,11884,12414],0); -ELEMENTS[1582] = Fluid3D([11884,12246,12199,12808],0); -ELEMENTS[1583] = Fluid3D([12246,12199,12808,12850],0); -ELEMENTS[1584] = Fluid3D([11884,12246,12808,12414],0); -ELEMENTS[1585] = Fluid3D([12199,11884,12808,12280],0); -ELEMENTS[1586] = Fluid3D([11167,11406,11393,10641],0); -ELEMENTS[1587] = Fluid3D([11393,11167,10641,10800],0); -ELEMENTS[1588] = Fluid3D([11406,11393,10641,10898],0); -ELEMENTS[1589] = Fluid3D([10641,11406,10898,10192],0); -ELEMENTS[1590] = Fluid3D([10898,10641,10192,9863],0); -ELEMENTS[1591] = Fluid3D([11167,11406,10641,10994],0); -ELEMENTS[1592] = Fluid3D([10898,10641,9863,10369],0); -ELEMENTS[1593] = Fluid3D([10898,10641,10369,11393],0); -ELEMENTS[1594] = Fluid3D([10641,9863,10369,9630],0); -ELEMENTS[1595] = Fluid3D([9863,10369,9630,9384],0); -ELEMENTS[1596] = Fluid3D([9863,10369,9384,10110],0); -ELEMENTS[1597] = Fluid3D([9630,9863,9384,8928],0); -ELEMENTS[1598] = Fluid3D([9863,10369,10110,10898],0); -ELEMENTS[1599] = Fluid3D([9630,9863,8928,9555],0); -ELEMENTS[1600] = Fluid3D([10641,9863,9630,9555],0); -ELEMENTS[1601] = Fluid3D([8928,9630,9555,8878],0); -ELEMENTS[1602] = Fluid3D([8928,9630,8878,8752],0); -ELEMENTS[1603] = Fluid3D([8928,9630,8752,9384],0); -ELEMENTS[1604] = Fluid3D([9630,9555,8878,9801],0); -ELEMENTS[1605] = Fluid3D([8878,9630,9801,9362],0); -ELEMENTS[1606] = Fluid3D([8878,9630,9362,8752],0); -ELEMENTS[1607] = Fluid3D([9555,8928,8878,8607],0); -ELEMENTS[1608] = Fluid3D([8878,9555,8607,9117],0); -ELEMENTS[1609] = Fluid3D([8878,9555,9117,9801],0); -ELEMENTS[1610] = Fluid3D([9630,9555,9801,10641],0); -ELEMENTS[1611] = Fluid3D([9555,8928,8607,9181],0); -ELEMENTS[1612] = Fluid3D([8928,8607,9181,8112],0); -ELEMENTS[1613] = Fluid3D([9555,8928,9181,9863],0); -ELEMENTS[1614] = Fluid3D([8607,9181,8112,8461],0); -ELEMENTS[1615] = Fluid3D([8607,9181,8461,9236],0); -ELEMENTS[1616] = Fluid3D([8607,9181,9236,9555],0); -ELEMENTS[1617] = Fluid3D([9181,8112,8461,8659],0); -ELEMENTS[1618] = Fluid3D([8112,8461,8659,7771],0); -ELEMENTS[1619] = Fluid3D([8112,8461,7771,7780],0); -ELEMENTS[1620] = Fluid3D([8112,8461,7780,8607],0); -ELEMENTS[1621] = Fluid3D([9181,8112,8659,8962],0); -ELEMENTS[1622] = Fluid3D([8112,8659,8962,7895],0); -ELEMENTS[1623] = Fluid3D([8112,8659,7895,7771],0); -ELEMENTS[1624] = Fluid3D([9181,8112,8962,8928],0); -ELEMENTS[1625] = Fluid3D([8928,8607,8112,7882],0); -ELEMENTS[1626] = Fluid3D([8928,8607,7882,8878],0); -ELEMENTS[1627] = Fluid3D([8607,8112,7882,7780],0); -ELEMENTS[1628] = Fluid3D([10641,11406,10192,10994],0); -ELEMENTS[1629] = Fluid3D([11406,11393,10898,12010],0); -ELEMENTS[1630] = Fluid3D([10192,10898,9863,10309],0); -ELEMENTS[1631] = Fluid3D([10192,10898,10309,11259],0); -ELEMENTS[1632] = Fluid3D([10898,10309,11259,11133],0); -ELEMENTS[1633] = Fluid3D([10898,10309,11133,10110],0); -ELEMENTS[1634] = Fluid3D([10898,9863,10309,10110],0); -ELEMENTS[1635] = Fluid3D([10309,10192,11259,10468],0); -ELEMENTS[1636] = Fluid3D([11259,10309,10468,10911],0); -ELEMENTS[1637] = Fluid3D([10309,10192,10468,9181],0); -ELEMENTS[1638] = Fluid3D([10192,11259,10468,11172],0); -ELEMENTS[1639] = Fluid3D([10192,11259,11172,11406],0); -ELEMENTS[1640] = Fluid3D([10309,10468,10911,9884],0); -ELEMENTS[1641] = Fluid3D([11259,10468,11172,11505],0); -ELEMENTS[1642] = Fluid3D([11259,10468,11505,10911],0); -ELEMENTS[1643] = Fluid3D([10309,10468,9884,9181],0); -ELEMENTS[1644] = Fluid3D([10468,10911,9884,10517],0); -ELEMENTS[1645] = Fluid3D([10192,10898,11259,11406],0); -ELEMENTS[1646] = Fluid3D([11259,10309,10911,11133],0); -ELEMENTS[1647] = Fluid3D([9863,10192,10309,9181],0); -ELEMENTS[1648] = Fluid3D([10369,10641,9630,10800],0); -ELEMENTS[1649] = Fluid3D([10641,10192,9863,9555],0); -ELEMENTS[1650] = Fluid3D([8878,8928,8752,7882],0); -ELEMENTS[1651] = Fluid3D([13947,14692,14603,14642],0); -ELEMENTS[1652] = Fluid3D([8659,9181,8962,9884],0); -ELEMENTS[1653] = Fluid3D([16859,16271,16415,16419],0); -ELEMENTS[1654] = Fluid3D([16271,16415,16419,15706],0); -ELEMENTS[1655] = Fluid3D([16859,16271,16419,16635],0); -ELEMENTS[1656] = Fluid3D([16419,16859,16635,16928],0); -ELEMENTS[1657] = Fluid3D([16419,16859,16928,16787],0); -ELEMENTS[1658] = Fluid3D([16928,16419,16787,16670],0); -ELEMENTS[1659] = Fluid3D([16635,16419,16928,16558],0); -ELEMENTS[1660] = Fluid3D([16928,16635,16558,16976],0); -ELEMENTS[1661] = Fluid3D([16928,16635,16976,17103],0); -ELEMENTS[1662] = Fluid3D([16928,16635,17103,16859],0); -ELEMENTS[1663] = Fluid3D([16635,16419,16558,15904],0); -ELEMENTS[1664] = Fluid3D([16859,16271,16635,16691],0); -ELEMENTS[1665] = Fluid3D([16419,16859,16787,16415],0); -ELEMENTS[1666] = Fluid3D([16787,16928,16670,17126],0); -ELEMENTS[1667] = Fluid3D([16787,16928,17126,17204],0); -ELEMENTS[1668] = Fluid3D([16928,16670,17126,17027],0); -ELEMENTS[1669] = Fluid3D([16670,16787,17126,16854],0); -ELEMENTS[1670] = Fluid3D([16670,16787,16854,16362],0); -ELEMENTS[1671] = Fluid3D([16670,16787,16362,16419],0); -ELEMENTS[1672] = Fluid3D([16928,16670,17027,16558],0); -ELEMENTS[1673] = Fluid3D([16670,17126,17027,17013],0); -ELEMENTS[1674] = Fluid3D([17126,17027,17013,17385],0); -ELEMENTS[1675] = Fluid3D([17126,17027,17385,17378],0); -ELEMENTS[1676] = Fluid3D([17126,17027,17378,16928],0); -ELEMENTS[1677] = Fluid3D([16670,17126,17013,16854],0); -ELEMENTS[1678] = Fluid3D([17027,16670,17013,16698],0); -ELEMENTS[1679] = Fluid3D([16670,17013,16698,16486],0); -ELEMENTS[1680] = Fluid3D([16698,16670,16486,16176],0); -ELEMENTS[1681] = Fluid3D([16698,16670,16176,16558],0); -ELEMENTS[1682] = Fluid3D([16670,17013,16486,16854],0); -ELEMENTS[1683] = Fluid3D([17027,16670,16698,16558],0); -ELEMENTS[1684] = Fluid3D([16787,16928,17204,16859],0); -ELEMENTS[1685] = Fluid3D([16928,16419,16670,16558],0); -ELEMENTS[1686] = Fluid3D([16928,17126,17204,17378],0); -ELEMENTS[1687] = Fluid3D([17126,16787,17204,17172],0); -ELEMENTS[1688] = Fluid3D([16787,17204,17172,16810],0); -ELEMENTS[1689] = Fluid3D([17204,17126,17172,17511],0); -ELEMENTS[1690] = Fluid3D([17172,17204,17511,17457],0); -ELEMENTS[1691] = Fluid3D([17126,16787,17172,16854],0); -ELEMENTS[1692] = Fluid3D([17204,17126,17511,17378],0); -ELEMENTS[1693] = Fluid3D([17126,17172,17511,17277],0); -ELEMENTS[1694] = Fluid3D([17126,17172,17277,16854],0); -ELEMENTS[1695] = Fluid3D([17172,17511,17277,17698],0); -ELEMENTS[1696] = Fluid3D([17172,17204,17457,16810],0); -ELEMENTS[1697] = Fluid3D([17511,17172,17457,17698],0); -ELEMENTS[1698] = Fluid3D([17511,17126,17277,17385],0); -ELEMENTS[1699] = Fluid3D([16635,16558,16976,16523],0); -ELEMENTS[1700] = Fluid3D([16635,16558,16523,15904],0); -ELEMENTS[1701] = Fluid3D([16558,16976,16523,16755],0); -ELEMENTS[1702] = Fluid3D([16976,16523,16755,16957],0); -ELEMENTS[1703] = Fluid3D([16523,16755,16957,16507],0); -ELEMENTS[1704] = Fluid3D([16976,16635,16523,16873],0); -ELEMENTS[1705] = Fluid3D([16635,16523,16873,16251],0); -ELEMENTS[1706] = Fluid3D([16523,16755,16507,16225],0); -ELEMENTS[1707] = Fluid3D([16976,16635,16873,17103],0); -ELEMENTS[1708] = Fluid3D([16755,16507,16225,16482],0); -ELEMENTS[1709] = Fluid3D([16507,16225,16482,16003],0); -ELEMENTS[1710] = Fluid3D([16507,16225,16003,16021],0); -ELEMENTS[1711] = Fluid3D([16507,16225,16021,16523],0); -ELEMENTS[1712] = Fluid3D([16755,16507,16482,16935],0); -ELEMENTS[1713] = Fluid3D([16755,16507,16935,16957],0); -ELEMENTS[1714] = Fluid3D([16507,16482,16935,16524],0); -ELEMENTS[1715] = Fluid3D([16507,16482,16524,16003],0); -ELEMENTS[1716] = Fluid3D([16935,16507,16524,16839],0); -ELEMENTS[1717] = Fluid3D([16507,16524,16839,16316],0); -ELEMENTS[1718] = Fluid3D([16935,16507,16839,16957],0); -ELEMENTS[1719] = Fluid3D([16507,16524,16316,16003],0); -ELEMENTS[1720] = Fluid3D([16523,16755,16225,16558],0); -ELEMENTS[1721] = Fluid3D([16976,16523,16957,16873],0); -ELEMENTS[1722] = Fluid3D([16558,16976,16755,17027],0); -ELEMENTS[1723] = Fluid3D([16524,16839,16316,16622],0); -ELEMENTS[1724] = Fluid3D([16524,16839,16622,17045],0); -ELEMENTS[1725] = Fluid3D([16839,16316,16622,16658],0); -ELEMENTS[1726] = Fluid3D([16839,16316,16658,16605],0); -ELEMENTS[1727] = Fluid3D([16316,16524,16622,16174],0); -ELEMENTS[1728] = Fluid3D([16316,16524,16174,16003],0); -ELEMENTS[1729] = Fluid3D([16839,16316,16605,16507],0); -ELEMENTS[1730] = Fluid3D([16316,16622,16658,16203],0); -ELEMENTS[1731] = Fluid3D([16622,16658,16203,16683],0); -ELEMENTS[1732] = Fluid3D([16658,16203,16683,16423],0); -ELEMENTS[1733] = Fluid3D([16658,16203,16423,16162],0); -ELEMENTS[1734] = Fluid3D([16622,16658,16683,17080],0); -ELEMENTS[1735] = Fluid3D([16622,16658,17080,16839],0); -ELEMENTS[1736] = Fluid3D([16316,16622,16203,16174],0); -ELEMENTS[1737] = Fluid3D([16658,16203,16162,16316],0); -ELEMENTS[1738] = Fluid3D([16839,16622,17045,17080],0); -ELEMENTS[1739] = Fluid3D([16316,16658,16605,16162],0); -ELEMENTS[1740] = Fluid3D([16524,16839,17045,16935],0); -ELEMENTS[1741] = Fluid3D([16482,16935,16524,16790],0); -ELEMENTS[1742] = Fluid3D([16482,16935,16790,16946],0); -ELEMENTS[1743] = Fluid3D([16935,16524,16790,17045],0); -ELEMENTS[1744] = Fluid3D([16935,16790,16946,17232],0); -ELEMENTS[1745] = Fluid3D([16946,16935,17232,17254],0); -ELEMENTS[1746] = Fluid3D([16935,16790,17232,17045],0); -ELEMENTS[1747] = Fluid3D([16790,16946,17232,17059],0); -ELEMENTS[1748] = Fluid3D([16946,17232,17059,17352],0); -ELEMENTS[1749] = Fluid3D([16946,17232,17352,17254],0); -ELEMENTS[1750] = Fluid3D([16946,16935,17254,16755],0); -ELEMENTS[1751] = Fluid3D([16790,16946,17059,16590],0); -ELEMENTS[1752] = Fluid3D([16946,17059,16590,16960],0); -ELEMENTS[1753] = Fluid3D([16946,17059,16960,17352],0); -ELEMENTS[1754] = Fluid3D([16790,16946,16590,16482],0); -ELEMENTS[1755] = Fluid3D([17059,16590,16960,16826],0); -ELEMENTS[1756] = Fluid3D([16960,17059,16826,17257],0); -ELEMENTS[1757] = Fluid3D([16960,17059,17257,17352],0); -ELEMENTS[1758] = Fluid3D([17059,16590,16826,16712],0); -ELEMENTS[1759] = Fluid3D([17059,16590,16712,16790],0); -ELEMENTS[1760] = Fluid3D([16590,16826,16712,16323],0); -ELEMENTS[1761] = Fluid3D([16826,16712,16323,16655],0); -ELEMENTS[1762] = Fluid3D([16826,16712,16655,17087],0); -ELEMENTS[1763] = Fluid3D([16826,16712,17087,17059],0); -ELEMENTS[1764] = Fluid3D([16590,16826,16323,16449],0); -ELEMENTS[1765] = Fluid3D([16826,16323,16449,16580],0); -ELEMENTS[1766] = Fluid3D([16826,16323,16580,16655],0); -ELEMENTS[1767] = Fluid3D([16590,16960,16826,16449],0); -ELEMENTS[1768] = Fluid3D([17232,17059,17352,17481],0); -ELEMENTS[1769] = Fluid3D([17352,17232,17481,17615],0); -ELEMENTS[1770] = Fluid3D([17059,17352,17481,17257],0); -ELEMENTS[1771] = Fluid3D([17232,17059,17481,17224],0); -ELEMENTS[1772] = Fluid3D([17232,17059,17224,16790],0); -ELEMENTS[1773] = Fluid3D([17059,17481,17224,17087],0); -ELEMENTS[1774] = Fluid3D([17352,17232,17615,17254],0); -ELEMENTS[1775] = Fluid3D([16524,16482,16790,16331],0); -ELEMENTS[1776] = Fluid3D([16482,16790,16331,16590],0); -ELEMENTS[1777] = Fluid3D([16524,16482,16331,16003],0); -ELEMENTS[1778] = Fluid3D([16790,16524,16331,16638],0); -ELEMENTS[1779] = Fluid3D([16331,16790,16638,16712],0); -ELEMENTS[1780] = Fluid3D([16524,16331,16638,16174],0); -ELEMENTS[1781] = Fluid3D([16790,16524,16638,17045],0); -ELEMENTS[1782] = Fluid3D([16826,16960,17257,16978],0); -ELEMENTS[1783] = Fluid3D([17257,16826,16978,17097],0); -ELEMENTS[1784] = Fluid3D([16960,17257,16978,17383],0); -ELEMENTS[1785] = Fluid3D([16826,16978,17097,16580],0); -ELEMENTS[1786] = Fluid3D([16960,17257,17383,17352],0); -ELEMENTS[1787] = Fluid3D([16826,16960,16978,16449],0); -ELEMENTS[1788] = Fluid3D([17257,16826,17097,17087],0); -ELEMENTS[1789] = Fluid3D([17257,16978,17383,17397],0); -ELEMENTS[1790] = Fluid3D([17257,16978,17397,17097],0); -ELEMENTS[1791] = Fluid3D([16978,17383,17397,17184],0); -ELEMENTS[1792] = Fluid3D([17397,16978,17184,17068],0); -ELEMENTS[1793] = Fluid3D([16978,17383,17184,16915],0); -ELEMENTS[1794] = Fluid3D([17397,16978,17068,17097],0); -ELEMENTS[1795] = Fluid3D([17383,17257,17397,17627],0); -ELEMENTS[1796] = Fluid3D([17383,17257,17627,17352],0); -ELEMENTS[1797] = Fluid3D([17257,17397,17627,17568],0); -ELEMENTS[1798] = Fluid3D([17397,17627,17568,17777],0); -ELEMENTS[1799] = Fluid3D([17397,17627,17777,17660],0); -ELEMENTS[1800] = Fluid3D([17397,17627,17660,17383],0); -ELEMENTS[1801] = Fluid3D([17257,17397,17568,17097],0); -ELEMENTS[1802] = Fluid3D([16978,17383,16915,16960],0); -ELEMENTS[1803] = Fluid3D([17383,17397,17184,17660],0); -ELEMENTS[1804] = Fluid3D([16978,17184,17068,16699],0); -ELEMENTS[1805] = Fluid3D([16978,17184,16699,16915],0); -ELEMENTS[1806] = Fluid3D([17068,16978,16699,16580],0); -ELEMENTS[1807] = Fluid3D([17184,17068,16699,17058],0); -ELEMENTS[1808] = Fluid3D([17184,17068,17058,17450],0); -ELEMENTS[1809] = Fluid3D([17068,17058,17450,17216],0); -ELEMENTS[1810] = Fluid3D([17068,17058,17216,16757],0); -ELEMENTS[1811] = Fluid3D([17068,17058,16757,16699],0); -ELEMENTS[1812] = Fluid3D([17184,17068,17450,17397],0); -ELEMENTS[1813] = Fluid3D([17058,17184,17450,17426],0); -ELEMENTS[1814] = Fluid3D([17058,17184,17426,16975],0); -ELEMENTS[1815] = Fluid3D([17058,17184,16975,16699],0); -ELEMENTS[1816] = Fluid3D([17450,17058,17426,17412],0); -ELEMENTS[1817] = Fluid3D([17450,17058,17412,17216],0); -ELEMENTS[1818] = Fluid3D([17058,17426,17412,17156],0); -ELEMENTS[1819] = Fluid3D([17412,17058,17156,17012],0); -ELEMENTS[1820] = Fluid3D([17058,17426,17156,16975],0); -ELEMENTS[1821] = Fluid3D([17412,17058,17012,17216],0); -ELEMENTS[1822] = Fluid3D([17184,17450,17426,17660],0); -ELEMENTS[1823] = Fluid3D([17232,17481,17615,17543],0); -ELEMENTS[1824] = Fluid3D([17232,17481,17543,17224],0); -ELEMENTS[1825] = Fluid3D([17481,17615,17543,17832],0); -ELEMENTS[1826] = Fluid3D([17481,17615,17832,17740],0); -ELEMENTS[1827] = Fluid3D([17481,17615,17740,17352],0); -ELEMENTS[1828] = Fluid3D([17615,17232,17543,17540],0); -ELEMENTS[1829] = Fluid3D([17615,17232,17540,17254],0); -ELEMENTS[1830] = Fluid3D([17543,17615,17540,17811],0); -ELEMENTS[1831] = Fluid3D([17615,17540,17811,17677],0); -ELEMENTS[1832] = Fluid3D([17615,17540,17677,17254],0); -ELEMENTS[1833] = Fluid3D([17543,17481,17832,17618],0); -ELEMENTS[1834] = Fluid3D([17543,17481,17618,17224],0); -ELEMENTS[1835] = Fluid3D([17481,17832,17618,17753],0); -ELEMENTS[1836] = Fluid3D([17832,17618,17753,18011],0); -ELEMENTS[1837] = Fluid3D([17832,17618,18011,17876],0); -ELEMENTS[1838] = Fluid3D([17832,17618,17876,17543],0); -ELEMENTS[1839] = Fluid3D([17481,17832,17753,17740],0); -ELEMENTS[1840] = Fluid3D([17543,17615,17811,17832],0); -ELEMENTS[1841] = Fluid3D([16482,16935,16946,16755],0); -ELEMENTS[1842] = Fluid3D([17426,17450,17412,17837],0); -ELEMENTS[1843] = Fluid3D([16755,16976,16957,17254],0); -ELEMENTS[1844] = Fluid3D([16622,16524,17045,16638],0); -ELEMENTS[1845] = Fluid3D([16935,17232,17254,17540],0); -ELEMENTS[1846] = Fluid3D([17027,17013,17385,17177],0); -ELEMENTS[1847] = Fluid3D([17013,17385,17177,17314],0); -ELEMENTS[1848] = Fluid3D([17385,17027,17177,17393],0); -ELEMENTS[1849] = Fluid3D([17385,17177,17314,17634],0); -ELEMENTS[1850] = Fluid3D([17385,17177,17634,17393],0); -ELEMENTS[1851] = Fluid3D([17177,17314,17634,17383],0); -ELEMENTS[1852] = Fluid3D([17027,17013,17177,16698],0); -ELEMENTS[1853] = Fluid3D([17027,17177,17393,17002],0); -ELEMENTS[1854] = Fluid3D([17393,17027,17002,16976],0); -ELEMENTS[1855] = Fluid3D([17027,17177,17002,16698],0); -ELEMENTS[1856] = Fluid3D([17177,17393,17002,17352],0); -ELEMENTS[1857] = Fluid3D([17385,17027,17393,17378],0); -ELEMENTS[1858] = Fluid3D([17013,17385,17314,17277],0); -ELEMENTS[1859] = Fluid3D([17314,17385,17634,17679],0); -ELEMENTS[1860] = Fluid3D([17634,17314,17679,17662],0); -ELEMENTS[1861] = Fluid3D([17314,17385,17679,17277],0); -ELEMENTS[1862] = Fluid3D([17314,17679,17662,17757],0); -ELEMENTS[1863] = Fluid3D([17385,17634,17679,17751],0); -ELEMENTS[1864] = Fluid3D([17385,17634,17751,17393],0); -ELEMENTS[1865] = Fluid3D([17634,17679,17751,17989],0); -ELEMENTS[1866] = Fluid3D([17679,17385,17751,17658],0); -ELEMENTS[1867] = Fluid3D([17679,17385,17658,17277],0); -ELEMENTS[1868] = Fluid3D([17385,17751,17658,17378],0); -ELEMENTS[1869] = Fluid3D([17634,17314,17662,17383],0); -ELEMENTS[1870] = Fluid3D([17679,17634,17662,17989],0); -ELEMENTS[1871] = Fluid3D([17751,17679,17658,18066],0); -ELEMENTS[1872] = Fluid3D([17177,17013,17314,16915],0); -ELEMENTS[1873] = Fluid3D([16957,16523,16507,16605],0); -ELEMENTS[1874] = Fluid3D([17204,17511,17457,17595],0); -ELEMENTS[1875] = Fluid3D([17204,17511,17595,17378],0); -ELEMENTS[1876] = Fluid3D([17457,17204,17595,17353],0); -ELEMENTS[1877] = Fluid3D([17457,17204,17353,16810],0); -ELEMENTS[1878] = Fluid3D([17595,17457,17353,17709],0); -ELEMENTS[1879] = Fluid3D([17457,17353,17709,17423],0); -ELEMENTS[1880] = Fluid3D([17353,17709,17423,17545],0); -ELEMENTS[1881] = Fluid3D([17353,17709,17545,17637],0); -ELEMENTS[1882] = Fluid3D([17709,17545,17637,17891],0); -ELEMENTS[1883] = Fluid3D([17353,17709,17637,17595],0); -ELEMENTS[1884] = Fluid3D([17709,17545,17891,17898],0); -ELEMENTS[1885] = Fluid3D([17891,17709,17898,18028],0); -ELEMENTS[1886] = Fluid3D([17511,17457,17595,17797],0); -ELEMENTS[1887] = Fluid3D([17637,17709,17891,17950],0); -ELEMENTS[1888] = Fluid3D([17637,17709,17950,17595],0); -ELEMENTS[1889] = Fluid3D([17709,17891,17950,18028],0); -ELEMENTS[1890] = Fluid3D([17950,17709,18028,17595],0); -ELEMENTS[1891] = Fluid3D([17891,17637,17950,17956],0); -ELEMENTS[1892] = Fluid3D([17891,17637,17956,17719],0); -ELEMENTS[1893] = Fluid3D([17950,17891,17956,18116],0); -ELEMENTS[1894] = Fluid3D([17950,17891,18116,18028],0); -ELEMENTS[1895] = Fluid3D([18116,17950,18028,18218],0); -ELEMENTS[1896] = Fluid3D([17950,18028,18218,18150],0); -ELEMENTS[1897] = Fluid3D([17891,17637,17719,17545],0); -ELEMENTS[1898] = Fluid3D([17637,17950,17956,17833],0); -ELEMENTS[1899] = Fluid3D([17637,17950,17833,17595],0); -ELEMENTS[1900] = Fluid3D([17950,17956,17833,18124],0); -ELEMENTS[1901] = Fluid3D([17950,17956,18124,18116],0); -ELEMENTS[1902] = Fluid3D([17833,17950,18124,17940],0); -ELEMENTS[1903] = Fluid3D([17950,18124,17940,18218],0); -ELEMENTS[1904] = Fluid3D([17950,18124,18218,18116],0); -ELEMENTS[1905] = Fluid3D([18124,17940,18218,18325],0); -ELEMENTS[1906] = Fluid3D([17833,17950,17940,17595],0); -ELEMENTS[1907] = Fluid3D([17956,17833,18124,17999],0); -ELEMENTS[1908] = Fluid3D([17956,17833,17999,17701],0); -ELEMENTS[1909] = Fluid3D([18124,17956,17999,18192],0); -ELEMENTS[1910] = Fluid3D([17833,18124,17999,18037],0); -ELEMENTS[1911] = Fluid3D([17833,18124,18037,17940],0); -ELEMENTS[1912] = Fluid3D([18124,17956,18192,18301],0); -ELEMENTS[1913] = Fluid3D([17956,17833,17701,17637],0); -ELEMENTS[1914] = Fluid3D([17956,17891,17719,18034],0); -ELEMENTS[1915] = Fluid3D([17956,17891,18034,18116],0); -ELEMENTS[1916] = Fluid3D([17891,17719,18034,17835],0); -ELEMENTS[1917] = Fluid3D([17719,17956,18034,17933],0); -ELEMENTS[1918] = Fluid3D([17891,17719,17835,17545],0); -ELEMENTS[1919] = Fluid3D([17719,17956,17933,17701],0); -ELEMENTS[1920] = Fluid3D([17719,18034,17835,17804],0); -ELEMENTS[1921] = Fluid3D([17719,18034,17804,17933],0); -ELEMENTS[1922] = Fluid3D([17835,17719,17804,17451],0); -ELEMENTS[1923] = Fluid3D([17719,17804,17451,17592],0); -ELEMENTS[1924] = Fluid3D([17835,17719,17451,17545],0); -ELEMENTS[1925] = Fluid3D([17719,17804,17592,17933],0); -ELEMENTS[1926] = Fluid3D([18034,17835,17804,18106],0); -ELEMENTS[1927] = Fluid3D([17956,18034,17933,18192],0); -ELEMENTS[1928] = Fluid3D([17709,17423,17545,17898],0); -ELEMENTS[1929] = Fluid3D([17595,17457,17709,17797],0); -ELEMENTS[1930] = Fluid3D([17457,17353,17423,16810],0); -ELEMENTS[1931] = Fluid3D([17637,17956,17719,17701],0); -ELEMENTS[1932] = Fluid3D([17545,17353,17637,17269],0); -ELEMENTS[1933] = Fluid3D([17637,17545,17269,17719],0); -ELEMENTS[1934] = Fluid3D([17353,17637,17269,17305],0); -ELEMENTS[1935] = Fluid3D([17353,17637,17305,17595],0); -ELEMENTS[1936] = Fluid3D([17545,17353,17269,17003],0); -ELEMENTS[1937] = Fluid3D([17353,17269,17003,17305],0); -ELEMENTS[1938] = Fluid3D([17637,17269,17305,17701],0); -ELEMENTS[1939] = Fluid3D([17204,17595,17353,17305],0); -ELEMENTS[1940] = Fluid3D([17709,17457,17423,17654],0); -ELEMENTS[1941] = Fluid3D([17423,17353,17545,17003],0); -ELEMENTS[1942] = Fluid3D([17999,17956,17701,17933],0); -ELEMENTS[1943] = Fluid3D([17156,17412,17012,17502],0); -ELEMENTS[1944] = Fluid3D([16271,16419,16635,15904],0); -ELEMENTS[1945] = Fluid3D([15564,15578,15701,15069],0); -ELEMENTS[1946] = Fluid3D([15564,15578,15069,15053],0); -ELEMENTS[1947] = Fluid3D([15701,15564,15069,15457],0); -ELEMENTS[1948] = Fluid3D([15578,15701,15069,14997],0); -ELEMENTS[1949] = Fluid3D([15701,15564,15457,16263],0); -ELEMENTS[1950] = Fluid3D([15069,15701,15457,15139],0); -ELEMENTS[1951] = Fluid3D([15457,15069,15139,14639],0); -ELEMENTS[1952] = Fluid3D([15457,15069,14639,15289],0); -ELEMENTS[1953] = Fluid3D([15139,15457,14639,15042],0); -ELEMENTS[1954] = Fluid3D([15457,14639,15042,14919],0); -ELEMENTS[1955] = Fluid3D([14639,15042,14919,14199],0); -ELEMENTS[1956] = Fluid3D([14639,15042,14199,14422],0); -ELEMENTS[1957] = Fluid3D([15069,15701,15139,14997],0); -ELEMENTS[1958] = Fluid3D([15042,14199,14422,14580],0); -ELEMENTS[1959] = Fluid3D([15042,14199,14580,14885],0); -ELEMENTS[1960] = Fluid3D([15042,14199,14885,14919],0); -ELEMENTS[1961] = Fluid3D([14199,14422,14580,13630],0); -ELEMENTS[1962] = Fluid3D([14639,15042,14422,15139],0); -ELEMENTS[1963] = Fluid3D([14422,14580,13630,14014],0); -ELEMENTS[1964] = Fluid3D([13630,14422,14014,13610],0); -ELEMENTS[1965] = Fluid3D([14580,13630,14014,13913],0); -ELEMENTS[1966] = Fluid3D([13630,14014,13913,13174],0); -ELEMENTS[1967] = Fluid3D([13630,14014,13174,13610],0); -ELEMENTS[1968] = Fluid3D([14580,13630,13913,14145],0); -ELEMENTS[1969] = Fluid3D([13630,13913,14145,13017],0); -ELEMENTS[1970] = Fluid3D([13630,13913,13017,13174],0); -ELEMENTS[1971] = Fluid3D([14145,13630,13017,12808],0); -ELEMENTS[1972] = Fluid3D([13913,14145,13017,13950],0); -ELEMENTS[1973] = Fluid3D([14580,13630,14145,14199],0); -ELEMENTS[1974] = Fluid3D([14199,14422,13630,13769],0); -ELEMENTS[1975] = Fluid3D([13630,14199,13769,12808],0); -ELEMENTS[1976] = Fluid3D([14199,14422,13769,14639],0); -ELEMENTS[1977] = Fluid3D([14422,13630,13769,13610],0); -ELEMENTS[1978] = Fluid3D([15457,14639,14919,15289],0); -ELEMENTS[1979] = Fluid3D([14422,15042,14580,15046],0); -ELEMENTS[1980] = Fluid3D([15042,14580,15046,15331],0); -ELEMENTS[1981] = Fluid3D([15046,15042,15331,15639],0); -ELEMENTS[1982] = Fluid3D([15046,15042,15639,15139],0); -ELEMENTS[1983] = Fluid3D([14580,14422,15046,14014],0); -ELEMENTS[1984] = Fluid3D([14422,15042,15046,15139],0); -ELEMENTS[1985] = Fluid3D([14580,15046,15331,15065],0); -ELEMENTS[1986] = Fluid3D([15042,14580,15331,14885],0); -ELEMENTS[1987] = Fluid3D([15331,15046,15639,15732],0); -ELEMENTS[1988] = Fluid3D([15139,15457,15042,15639],0); -ELEMENTS[1989] = Fluid3D([15042,15457,14919,15543],0); -ELEMENTS[1990] = Fluid3D([14919,15042,15543,14885],0); -ELEMENTS[1991] = Fluid3D([15457,14919,15543,15382],0); -ELEMENTS[1992] = Fluid3D([15042,15457,15543,15639],0); -ELEMENTS[1993] = Fluid3D([15457,14919,15382,15289],0); -ELEMENTS[1994] = Fluid3D([15382,15457,15289,15564],0); -ELEMENTS[1995] = Fluid3D([15457,15289,15564,15069],0); -ELEMENTS[1996] = Fluid3D([15543,15457,15382,16263],0); -ELEMENTS[1997] = Fluid3D([15289,15382,15564,15742],0); -ELEMENTS[1998] = Fluid3D([14919,15543,15382,15303],0); -ELEMENTS[1999] = Fluid3D([14919,15543,15303,14885],0); -ELEMENTS[2000] = Fluid3D([15543,15382,15303,15951],0); -ELEMENTS[2001] = Fluid3D([15303,15543,15951,16080],0); -ELEMENTS[2002] = Fluid3D([15543,15382,15951,16263],0); -ELEMENTS[2003] = Fluid3D([15382,14919,15303,14607],0); -ELEMENTS[2004] = Fluid3D([15382,15303,15951,15641],0); -ELEMENTS[2005] = Fluid3D([15303,15951,15641,15660],0); -ELEMENTS[2006] = Fluid3D([15382,15303,15641,14607],0); -ELEMENTS[2007] = Fluid3D([15951,15382,15641,16075],0); -ELEMENTS[2008] = Fluid3D([15951,15382,16075,16263],0); -ELEMENTS[2009] = Fluid3D([15382,15641,16075,15742],0); -ELEMENTS[2010] = Fluid3D([15641,15951,16075,16250],0); -ELEMENTS[2011] = Fluid3D([15641,15951,16250,16267],0); -ELEMENTS[2012] = Fluid3D([15951,16250,16267,16631],0); -ELEMENTS[2013] = Fluid3D([15951,16075,16250,16487],0); -ELEMENTS[2014] = Fluid3D([16250,15951,16487,16631],0); -ELEMENTS[2015] = Fluid3D([15951,16075,16487,16263],0); -ELEMENTS[2016] = Fluid3D([16075,16250,16487,16578],0); -ELEMENTS[2017] = Fluid3D([16250,16487,16578,16791],0); -ELEMENTS[2018] = Fluid3D([16075,16250,16578,15851],0); -ELEMENTS[2019] = Fluid3D([16487,16075,16578,16616],0); -ELEMENTS[2020] = Fluid3D([16075,15641,16250,15851],0); -ELEMENTS[2021] = Fluid3D([15069,15139,14639,14366],0); -ELEMENTS[2022] = Fluid3D([14639,15069,14366,14596],0); -ELEMENTS[2023] = Fluid3D([15069,14366,14596,14997],0); -ELEMENTS[2024] = Fluid3D([14596,15069,14997,15578],0); -ELEMENTS[2025] = Fluid3D([14366,14596,14997,14332],0); -ELEMENTS[2026] = Fluid3D([14639,15069,14596,14746],0); -ELEMENTS[2027] = Fluid3D([15069,14596,14746,15053],0); -ELEMENTS[2028] = Fluid3D([14746,15069,15053,15289],0); -ELEMENTS[2029] = Fluid3D([15053,14746,15289,14593],0); -ELEMENTS[2030] = Fluid3D([15053,14746,14593,14275],0); -ELEMENTS[2031] = Fluid3D([14746,14593,14275,13999],0); -ELEMENTS[2032] = Fluid3D([14746,14593,13999,14466],0); -ELEMENTS[2033] = Fluid3D([14746,15289,14593,14466],0); -ELEMENTS[2034] = Fluid3D([15053,14746,14275,14596],0); -ELEMENTS[2035] = Fluid3D([14275,14746,13999,14596],0); -ELEMENTS[2036] = Fluid3D([14593,14275,13999,13741],0); -ELEMENTS[2037] = Fluid3D([14593,15053,14275,14581],0); -ELEMENTS[2038] = Fluid3D([14596,15069,15578,15053],0); -ELEMENTS[2039] = Fluid3D([14639,15069,14746,15289],0); -ELEMENTS[2040] = Fluid3D([15139,14639,14366,14422],0); -ELEMENTS[2041] = Fluid3D([15069,15139,14366,14997],0); -ELEMENTS[2042] = Fluid3D([14275,14593,14581,13741],0); -ELEMENTS[2043] = Fluid3D([15042,15331,15639,15543],0); -ELEMENTS[2044] = Fluid3D([14919,14639,14199,14466],0); -ELEMENTS[2045] = Fluid3D([14199,14919,14466,14612],0); -ELEMENTS[2046] = Fluid3D([14919,14466,14612,14607],0); -ELEMENTS[2047] = Fluid3D([14919,14639,14466,15289],0); -ELEMENTS[2048] = Fluid3D([14199,14919,14612,14885],0); -ELEMENTS[2049] = Fluid3D([14919,14612,14885,15303],0); -ELEMENTS[2050] = Fluid3D([14612,14199,14885,14145],0); -ELEMENTS[2051] = Fluid3D([14919,14612,15303,14607],0); -ELEMENTS[2052] = Fluid3D([15701,15457,15139,15639],0); -ELEMENTS[2053] = Fluid3D([16558,16928,16976,17027],0); -ELEMENTS[2054] = Fluid3D([12442,11643,11909,11673],0); -ELEMENTS[2055] = Fluid3D([12442,11643,11673,12184],0); -ELEMENTS[2056] = Fluid3D([11643,11909,11673,10855],0); -ELEMENTS[2057] = Fluid3D([11673,11643,10855,10817],0); -ELEMENTS[2058] = Fluid3D([11643,11673,12184,10817],0); -ELEMENTS[2059] = Fluid3D([11909,12442,11673,12394],0); -ELEMENTS[2060] = Fluid3D([11673,12442,12184,12591],0); -ELEMENTS[2061] = Fluid3D([11909,11673,10855,11178],0); -ELEMENTS[2062] = Fluid3D([11909,11673,11178,12394],0); -ELEMENTS[2063] = Fluid3D([11673,10855,11178,10845],0); -ELEMENTS[2064] = Fluid3D([11673,10855,10845,10817],0); -ELEMENTS[2065] = Fluid3D([11178,11673,10845,11958],0); -ELEMENTS[2066] = Fluid3D([11643,11909,10855,11189],0); -ELEMENTS[2067] = Fluid3D([10855,11178,10845,10293],0); -ELEMENTS[2068] = Fluid3D([10845,10855,10293,9965],0); -ELEMENTS[2069] = Fluid3D([10855,11909,11178,11171],0); -ELEMENTS[2070] = Fluid3D([10855,11178,10293,11171],0); -ELEMENTS[2071] = Fluid3D([10293,10845,9965,9710],0); -ELEMENTS[2072] = Fluid3D([10845,10855,9965,10817],0); -ELEMENTS[2073] = Fluid3D([10855,10293,9965,9385],0); -ELEMENTS[2074] = Fluid3D([11178,10845,10293,10833],0); -ELEMENTS[2075] = Fluid3D([10845,10293,10833,9710],0); -ELEMENTS[2076] = Fluid3D([11178,10845,10833,11958],0); -ELEMENTS[2077] = Fluid3D([10293,11178,10833,11520],0); -ELEMENTS[2078] = Fluid3D([11673,12442,12591,12394],0); -ELEMENTS[2079] = Fluid3D([14199,14580,14885,14145],0); -ELEMENTS[2080] = Fluid3D([9571,8779,8916,8615],0); -ELEMENTS[2081] = Fluid3D([12844,13456,13917,13368],0); -ELEMENTS[2082] = Fluid3D([13917,12844,13368,13249],0); -ELEMENTS[2083] = Fluid3D([12844,13456,13368,12612],0); -ELEMENTS[2084] = Fluid3D([13456,13917,13368,14163],0); -ELEMENTS[2085] = Fluid3D([13917,13368,14163,14102],0); -ELEMENTS[2086] = Fluid3D([13456,13917,14163,14157],0); -ELEMENTS[2087] = Fluid3D([13368,14163,14102,13975],0); -ELEMENTS[2088] = Fluid3D([14102,13368,13975,13494],0); -ELEMENTS[2089] = Fluid3D([13368,13456,14163,13691],0); -ELEMENTS[2090] = Fluid3D([13975,14102,13494,14315],0); -ELEMENTS[2091] = Fluid3D([13975,14102,14315,14759],0); -ELEMENTS[2092] = Fluid3D([13975,14102,14759,14163],0); -ELEMENTS[2093] = Fluid3D([13368,13456,13691,12612],0); -ELEMENTS[2094] = Fluid3D([14315,13975,14759,14616],0); -ELEMENTS[2095] = Fluid3D([13975,14759,14616,14613],0); -ELEMENTS[2096] = Fluid3D([13975,14759,14613,14163],0); -ELEMENTS[2097] = Fluid3D([14315,13975,14616,13720],0); -ELEMENTS[2098] = Fluid3D([14759,14616,14613,15203],0); -ELEMENTS[2099] = Fluid3D([14613,14759,15203,15054],0); -ELEMENTS[2100] = Fluid3D([14613,14759,15054,14163],0); -ELEMENTS[2101] = Fluid3D([14759,14616,15203,15159],0); -ELEMENTS[2102] = Fluid3D([14759,14616,15159,14315],0); -ELEMENTS[2103] = Fluid3D([14616,15203,15159,15277],0); -ELEMENTS[2104] = Fluid3D([15159,14616,15277,14799],0); -ELEMENTS[2105] = Fluid3D([15159,14616,14799,14315],0); -ELEMENTS[2106] = Fluid3D([14616,14613,15203,14918],0); -ELEMENTS[2107] = Fluid3D([14613,15203,14918,15346],0); -ELEMENTS[2108] = Fluid3D([14613,15203,15346,15054],0); -ELEMENTS[2109] = Fluid3D([14616,15203,15277,14918],0); -ELEMENTS[2110] = Fluid3D([14616,14613,14918,14103],0); -ELEMENTS[2111] = Fluid3D([14613,14918,14103,14469],0); -ELEMENTS[2112] = Fluid3D([14613,14918,14469,15346],0); -ELEMENTS[2113] = Fluid3D([14616,14613,14103,13975],0); -ELEMENTS[2114] = Fluid3D([14918,14616,14103,14507],0); -ELEMENTS[2115] = Fluid3D([14918,14616,14507,15277],0); -ELEMENTS[2116] = Fluid3D([14616,14103,14507,13720],0); -ELEMENTS[2117] = Fluid3D([14103,14507,13720,13349],0); -ELEMENTS[2118] = Fluid3D([14102,13368,13494,13249],0); -ELEMENTS[2119] = Fluid3D([13368,14163,13975,13691],0); -ELEMENTS[2120] = Fluid3D([15203,14759,15159,15456],0); -ELEMENTS[2121] = Fluid3D([15203,14759,15456,15054],0); -ELEMENTS[2122] = Fluid3D([14759,15159,15456,15008],0); -ELEMENTS[2123] = Fluid3D([14759,15159,15008,14315],0); -ELEMENTS[2124] = Fluid3D([15456,14759,15008,15010],0); -ELEMENTS[2125] = Fluid3D([15456,14759,15010,15054],0); -ELEMENTS[2126] = Fluid3D([14759,15008,15010,14102],0); -ELEMENTS[2127] = Fluid3D([15159,15203,15456,15787],0); -ELEMENTS[2128] = Fluid3D([15203,15456,15787,15824],0); -ELEMENTS[2129] = Fluid3D([15456,15159,15787,15697],0); -ELEMENTS[2130] = Fluid3D([15456,15787,15824,16106],0); -ELEMENTS[2131] = Fluid3D([15159,15203,15787,15277],0); -ELEMENTS[2132] = Fluid3D([15456,15159,15697,15008],0); -ELEMENTS[2133] = Fluid3D([15456,15787,16106,15697],0); -ELEMENTS[2134] = Fluid3D([15203,15456,15824,15054],0); -ELEMENTS[2135] = Fluid3D([15008,15456,15010,15553],0); -ELEMENTS[2136] = Fluid3D([15456,15010,15553,15670],0); -ELEMENTS[2137] = Fluid3D([15008,15456,15553,15697],0); -ELEMENTS[2138] = Fluid3D([15553,15456,15670,16106],0); -ELEMENTS[2139] = Fluid3D([15010,15008,15553,14943],0); -ELEMENTS[2140] = Fluid3D([15553,15010,14943,15354],0); -ELEMENTS[2141] = Fluid3D([15553,15010,15354,15670],0); -ELEMENTS[2142] = Fluid3D([15010,15008,14943,14102],0); -ELEMENTS[2143] = Fluid3D([15008,15553,14943,15351],0); -ELEMENTS[2144] = Fluid3D([15553,14943,15351,15545],0); -ELEMENTS[2145] = Fluid3D([15553,14943,15545,15354],0); -ELEMENTS[2146] = Fluid3D([14943,15008,15351,14595],0); -ELEMENTS[2147] = Fluid3D([14943,15008,14595,14102],0); -ELEMENTS[2148] = Fluid3D([15008,15553,15351,15697],0); -ELEMENTS[2149] = Fluid3D([15008,15351,14595,15161],0); -ELEMENTS[2150] = Fluid3D([14595,15008,15161,14315],0); -ELEMENTS[2151] = Fluid3D([15008,15351,15161,15697],0); -ELEMENTS[2152] = Fluid3D([15351,14595,15161,15000],0); -ELEMENTS[2153] = Fluid3D([14595,15161,15000,14293],0); -ELEMENTS[2154] = Fluid3D([15000,14595,14293,13995],0); -ELEMENTS[2155] = Fluid3D([15351,14595,15000,14938],0); -ELEMENTS[2156] = Fluid3D([15351,14595,14938,14943],0); -ELEMENTS[2157] = Fluid3D([14595,15000,14938,13995],0); -ELEMENTS[2158] = Fluid3D([15161,15351,15000,15627],0); -ELEMENTS[2159] = Fluid3D([15000,15161,15627,15134],0); -ELEMENTS[2160] = Fluid3D([15000,15161,15134,14293],0); -ELEMENTS[2161] = Fluid3D([15161,15351,15627,15697],0); -ELEMENTS[2162] = Fluid3D([15351,15000,15627,15683],0); -ELEMENTS[2163] = Fluid3D([15000,15627,15683,15492],0); -ELEMENTS[2164] = Fluid3D([15000,15627,15492,15134],0); -ELEMENTS[2165] = Fluid3D([15351,15000,15683,14938],0); -ELEMENTS[2166] = Fluid3D([15627,15351,15683,16098],0); -ELEMENTS[2167] = Fluid3D([15683,15627,16098,16151],0); -ELEMENTS[2168] = Fluid3D([15683,15627,16151,15492],0); -ELEMENTS[2169] = Fluid3D([15627,15351,16098,15697],0); -ELEMENTS[2170] = Fluid3D([15351,15683,16098,15545],0); -ELEMENTS[2171] = Fluid3D([15456,15010,15670,15054],0); -ELEMENTS[2172] = Fluid3D([15787,15203,15824,15803],0); -ELEMENTS[2173] = Fluid3D([15203,15824,15803,15346],0); -ELEMENTS[2174] = Fluid3D([15787,15203,15803,15277],0); -ELEMENTS[2175] = Fluid3D([15824,15787,15803,16295],0); -ELEMENTS[2176] = Fluid3D([15787,15803,16295,16095],0); -ELEMENTS[2177] = Fluid3D([15787,15803,16095,15277],0); -ELEMENTS[2178] = Fluid3D([15803,16295,16095,16337],0); -ELEMENTS[2179] = Fluid3D([15803,16295,16337,16193],0); -ELEMENTS[2180] = Fluid3D([15803,16295,16193,15824],0); -ELEMENTS[2181] = Fluid3D([15824,15787,16295,16106],0); -ELEMENTS[2182] = Fluid3D([16295,16095,16337,16641],0); -ELEMENTS[2183] = Fluid3D([16337,16295,16641,16717],0); -ELEMENTS[2184] = Fluid3D([16337,16295,16717,16193],0); -ELEMENTS[2185] = Fluid3D([16095,16337,16641,16432],0); -ELEMENTS[2186] = Fluid3D([16095,16337,16432,15897],0); -ELEMENTS[2187] = Fluid3D([16095,16337,15897,15803],0); -ELEMENTS[2188] = Fluid3D([16295,16095,16641,16371],0); -ELEMENTS[2189] = Fluid3D([16295,16095,16371,15787],0); -ELEMENTS[2190] = Fluid3D([16641,16095,16432,16459],0); -ELEMENTS[2191] = Fluid3D([16095,16641,16371,16459],0); -ELEMENTS[2192] = Fluid3D([16432,16641,16459,16895],0); -ELEMENTS[2193] = Fluid3D([16432,16641,16895,16857],0); -ELEMENTS[2194] = Fluid3D([16432,16641,16857,16337],0); -ELEMENTS[2195] = Fluid3D([16459,16432,16895,16567],0); -ELEMENTS[2196] = Fluid3D([16459,16432,16567,16038],0); -ELEMENTS[2197] = Fluid3D([16459,16432,16038,16095],0); -ELEMENTS[2198] = Fluid3D([16641,16459,16895,16898],0); -ELEMENTS[2199] = Fluid3D([16895,16641,16898,17123],0); -ELEMENTS[2200] = Fluid3D([16895,16641,17123,16857],0); -ELEMENTS[2201] = Fluid3D([16895,16459,16567,16836],0); -ELEMENTS[2202] = Fluid3D([16641,16459,16898,16371],0); -ELEMENTS[2203] = Fluid3D([16567,16895,16836,17114],0); -ELEMENTS[2204] = Fluid3D([16895,16459,16836,16898],0); -ELEMENTS[2205] = Fluid3D([16567,16895,17114,16756],0); -ELEMENTS[2206] = Fluid3D([16567,16895,16756,16432],0); -ELEMENTS[2207] = Fluid3D([16895,16836,17114,17168],0); -ELEMENTS[2208] = Fluid3D([16836,17114,17168,17236],0); -ELEMENTS[2209] = Fluid3D([16836,17114,17236,16831],0); -ELEMENTS[2210] = Fluid3D([17114,17236,16831,17244],0); -ELEMENTS[2211] = Fluid3D([17114,17236,17244,17433],0); -ELEMENTS[2212] = Fluid3D([17114,17236,17433,17168],0); -ELEMENTS[2213] = Fluid3D([16895,17114,16756,17296],0); -ELEMENTS[2214] = Fluid3D([16895,17114,17296,17168],0); -ELEMENTS[2215] = Fluid3D([16756,16895,17296,16857],0); -ELEMENTS[2216] = Fluid3D([16836,17114,16831,16567],0); -ELEMENTS[2217] = Fluid3D([16895,16836,17168,16898],0); -ELEMENTS[2218] = Fluid3D([15010,14943,15354,14468],0); -ELEMENTS[2219] = Fluid3D([15010,14943,14468,14102],0); -ELEMENTS[2220] = Fluid3D([15354,15010,14468,15056],0); -ELEMENTS[2221] = Fluid3D([15354,15010,15056,15670],0); -ELEMENTS[2222] = Fluid3D([15010,14468,15056,14398],0); -ELEMENTS[2223] = Fluid3D([15010,14468,14398,14102],0); -ELEMENTS[2224] = Fluid3D([14943,15354,14468,14908],0); -ELEMENTS[2225] = Fluid3D([14468,14943,14908,13845],0); -ELEMENTS[2226] = Fluid3D([14943,15354,14908,15545],0); -ELEMENTS[2227] = Fluid3D([15354,14468,14908,14959],0); -ELEMENTS[2228] = Fluid3D([15354,14468,14959,15056],0); -ELEMENTS[2229] = Fluid3D([14468,14908,14959,13953],0); -ELEMENTS[2230] = Fluid3D([14908,15354,14959,15541],0); -ELEMENTS[2231] = Fluid3D([14908,15354,15541,15545],0); -ELEMENTS[2232] = Fluid3D([14468,15056,14398,14157],0); -ELEMENTS[2233] = Fluid3D([15354,14959,15541,15650],0); -ELEMENTS[2234] = Fluid3D([15354,14959,15650,15056],0); -ELEMENTS[2235] = Fluid3D([14959,15541,15650,15470],0); -ELEMENTS[2236] = Fluid3D([14959,15541,15470,15072],0); -ELEMENTS[2237] = Fluid3D([14959,15541,15072,14908],0); -ELEMENTS[2238] = Fluid3D([15650,14959,15470,15222],0); -ELEMENTS[2239] = Fluid3D([15650,14959,15222,15056],0); -ELEMENTS[2240] = Fluid3D([15470,15650,15222,15866],0); -ELEMENTS[2241] = Fluid3D([15650,15222,15866,15709],0); -ELEMENTS[2242] = Fluid3D([15650,15222,15709,15056],0); -ELEMENTS[2243] = Fluid3D([15470,15650,15866,16078],0); -ELEMENTS[2244] = Fluid3D([15470,15650,16078,15541],0); -ELEMENTS[2245] = Fluid3D([15650,15866,16078,16232],0); -ELEMENTS[2246] = Fluid3D([15650,15866,16232,15709],0); -ELEMENTS[2247] = Fluid3D([16078,15650,16232,16122],0); -ELEMENTS[2248] = Fluid3D([16078,15650,16122,15541],0); -ELEMENTS[2249] = Fluid3D([16232,16078,16122,16583],0); -ELEMENTS[2250] = Fluid3D([16078,16122,16583,16280],0); -ELEMENTS[2251] = Fluid3D([16078,16122,16280,15541],0); -ELEMENTS[2252] = Fluid3D([16232,16078,16583,16472],0); -ELEMENTS[2253] = Fluid3D([16232,16078,16472,15866],0); -ELEMENTS[2254] = Fluid3D([16078,16583,16472,16574],0); -ELEMENTS[2255] = Fluid3D([16078,16583,16574,16280],0); -ELEMENTS[2256] = Fluid3D([16472,16078,16574,16149],0); -ELEMENTS[2257] = Fluid3D([16574,16472,16149,16696],0); -ELEMENTS[2258] = Fluid3D([16472,16149,16696,16325],0); -ELEMENTS[2259] = Fluid3D([16696,16472,16325,16800],0); -ELEMENTS[2260] = Fluid3D([16472,16078,16149,15866],0); -ELEMENTS[2261] = Fluid3D([15541,15354,15650,16122],0); -ELEMENTS[2262] = Fluid3D([16583,16472,16574,16875],0); -ELEMENTS[2263] = Fluid3D([16583,16472,16875,16761],0); -ELEMENTS[2264] = Fluid3D([16472,16875,16761,16800],0); -ELEMENTS[2265] = Fluid3D([16472,16574,16875,16696],0); -ELEMENTS[2266] = Fluid3D([16583,16472,16761,16232],0); -ELEMENTS[2267] = Fluid3D([16574,16583,16875,16894],0); -ELEMENTS[2268] = Fluid3D([16583,16875,16894,17054],0); -ELEMENTS[2269] = Fluid3D([16875,16894,17054,17307],0); -ELEMENTS[2270] = Fluid3D([16875,16894,17307,17040],0); -ELEMENTS[2271] = Fluid3D([16875,16894,17040,16574],0); -ELEMENTS[2272] = Fluid3D([16574,16583,16894,16280],0); -ELEMENTS[2273] = Fluid3D([16583,16875,17054,16761],0); -ELEMENTS[2274] = Fluid3D([14943,15351,15545,14938],0); -ELEMENTS[2275] = Fluid3D([16641,16337,16717,16857],0); -ELEMENTS[2276] = Fluid3D([16641,16295,16371,16750],0); -ELEMENTS[2277] = Fluid3D([16641,16295,16750,16717],0); -ELEMENTS[2278] = Fluid3D([16295,16371,16750,16106],0); -ELEMENTS[2279] = Fluid3D([16371,16641,16750,16898],0); -ELEMENTS[2280] = Fluid3D([14959,15470,15222,14764],0); -ELEMENTS[2281] = Fluid3D([14959,15470,14764,15072],0); -ELEMENTS[2282] = Fluid3D([15470,15222,14764,14881],0); -ELEMENTS[2283] = Fluid3D([15222,14959,14764,14477],0); -ELEMENTS[2284] = Fluid3D([15222,14959,14477,15056],0); -ELEMENTS[2285] = Fluid3D([14959,14764,14477,13953],0); -ELEMENTS[2286] = Fluid3D([14764,15222,14477,14688],0); -ELEMENTS[2287] = Fluid3D([15222,14477,14688,14837],0); -ELEMENTS[2288] = Fluid3D([14477,14688,14837,13716],0); -ELEMENTS[2289] = Fluid3D([14764,15222,14688,14881],0); -ELEMENTS[2290] = Fluid3D([14688,14764,14881,14097],0); -ELEMENTS[2291] = Fluid3D([15222,14477,14837,15056],0); -ELEMENTS[2292] = Fluid3D([14688,15222,14837,15314],0); -ELEMENTS[2293] = Fluid3D([15222,14837,15314,15709],0); -ELEMENTS[2294] = Fluid3D([14837,14688,15314,14675],0); -ELEMENTS[2295] = Fluid3D([14688,15222,15314,14881],0); -ELEMENTS[2296] = Fluid3D([14688,15314,14675,14480],0); -ELEMENTS[2297] = Fluid3D([14675,14688,14480,13964],0); -ELEMENTS[2298] = Fluid3D([14688,14480,13964,14105],0); -ELEMENTS[2299] = Fluid3D([14480,14675,13964,14071],0); -ELEMENTS[2300] = Fluid3D([13964,14480,14071,13805],0); -ELEMENTS[2301] = Fluid3D([14480,14675,14071,14825],0); -ELEMENTS[2302] = Fluid3D([14480,14675,14825,15314],0); -ELEMENTS[2303] = Fluid3D([14071,14480,14825,14517],0); -ELEMENTS[2304] = Fluid3D([14480,14825,14517,15319],0); -ELEMENTS[2305] = Fluid3D([14825,14517,15319,15471],0); -ELEMENTS[2306] = Fluid3D([14480,14825,15319,15314],0); -ELEMENTS[2307] = Fluid3D([14675,14688,13964,14837],0); -ELEMENTS[2308] = Fluid3D([14675,14071,14825,14547],0); -ELEMENTS[2309] = Fluid3D([14825,14675,14547,15260],0); -ELEMENTS[2310] = Fluid3D([14825,14675,15260,15314],0); -ELEMENTS[2311] = Fluid3D([14547,14825,15260,14912],0); -ELEMENTS[2312] = Fluid3D([15260,14547,14912,15004],0); -ELEMENTS[2313] = Fluid3D([14547,14912,15004,14281],0); -ELEMENTS[2314] = Fluid3D([14547,14912,14281,14179],0); -ELEMENTS[2315] = Fluid3D([14675,14071,14547,14003],0); -ELEMENTS[2316] = Fluid3D([14547,14675,14003,14786],0); -ELEMENTS[2317] = Fluid3D([14547,14675,14786,15260],0); -ELEMENTS[2318] = Fluid3D([14547,14825,14912,14250],0); -ELEMENTS[2319] = Fluid3D([14912,14547,14250,14179],0); -ELEMENTS[2320] = Fluid3D([14250,14912,14179,14817],0); -ELEMENTS[2321] = Fluid3D([14179,14250,14817,14073],0); -ELEMENTS[2322] = Fluid3D([14547,14250,14179,13672],0); -ELEMENTS[2323] = Fluid3D([14250,14179,13672,13023],0); -ELEMENTS[2324] = Fluid3D([14547,14250,13672,14071],0); -ELEMENTS[2325] = Fluid3D([14250,13672,14071,13023],0); -ELEMENTS[2326] = Fluid3D([14547,14250,14071,14825],0); -ELEMENTS[2327] = Fluid3D([14675,14071,14003,13964],0); -ELEMENTS[2328] = Fluid3D([14675,14003,14786,14837],0); -ELEMENTS[2329] = Fluid3D([14003,14547,14786,14237],0); -ELEMENTS[2330] = Fluid3D([14547,14786,14237,15004],0); -ELEMENTS[2331] = Fluid3D([14786,14237,15004,15133],0); -ELEMENTS[2332] = Fluid3D([14003,14547,14237,13672],0); -ELEMENTS[2333] = Fluid3D([14786,14003,14237,14154],0); -ELEMENTS[2334] = Fluid3D([14237,14786,14154,15133],0); -ELEMENTS[2335] = Fluid3D([14003,14237,14154,13153],0); -ELEMENTS[2336] = Fluid3D([14786,14003,14154,14403],0); -ELEMENTS[2337] = Fluid3D([14154,14786,14403,14873],0); -ELEMENTS[2338] = Fluid3D([14154,14786,14873,15133],0); -ELEMENTS[2339] = Fluid3D([14786,14003,14403,14837],0); -ELEMENTS[2340] = Fluid3D([14003,14154,14403,13153],0); -ELEMENTS[2341] = Fluid3D([14786,14403,14873,14837],0); -ELEMENTS[2342] = Fluid3D([15314,14837,14675,15208],0); -ELEMENTS[2343] = Fluid3D([15314,14837,15208,15709],0); -ELEMENTS[2344] = Fluid3D([14837,14675,15208,14786],0); -ELEMENTS[2345] = Fluid3D([14675,15208,14786,15260],0); -ELEMENTS[2346] = Fluid3D([15208,14786,15260,15662],0); -ELEMENTS[2347] = Fluid3D([14675,15208,15260,15314],0); -ELEMENTS[2348] = Fluid3D([14477,14764,14688,14097],0); -ELEMENTS[2349] = Fluid3D([14477,14764,14097,13953],0); -ELEMENTS[2350] = Fluid3D([14097,14477,13953,13716],0); -ELEMENTS[2351] = Fluid3D([14097,14477,13716,14688],0); -ELEMENTS[2352] = Fluid3D([14071,14547,14003,13672],0); -ELEMENTS[2353] = Fluid3D([13917,13368,14102,13249],0); -ELEMENTS[2354] = Fluid3D([13456,14163,13691,14195],0); -ELEMENTS[2355] = Fluid3D([13456,14163,14195,14157],0); -ELEMENTS[2356] = Fluid3D([14163,13691,14195,14613],0); -ELEMENTS[2357] = Fluid3D([13691,13456,14195,13027],0); -ELEMENTS[2358] = Fluid3D([15159,15787,15697,15570],0); -ELEMENTS[2359] = Fluid3D([15697,15159,15570,15161],0); -ELEMENTS[2360] = Fluid3D([15787,15697,15570,16371],0); -ELEMENTS[2361] = Fluid3D([15159,15787,15570,15277],0); -ELEMENTS[2362] = Fluid3D([15161,15627,15134,15505],0); -ELEMENTS[2363] = Fluid3D([15161,15627,15505,15697],0); -ELEMENTS[2364] = Fluid3D([15134,15161,15505,14855],0); -ELEMENTS[2365] = Fluid3D([15134,15161,14855,14293],0); -ELEMENTS[2366] = Fluid3D([15505,15134,14855,15339],0); -ELEMENTS[2367] = Fluid3D([15134,14855,15339,14290],0); -ELEMENTS[2368] = Fluid3D([15627,15134,15505,15806],0); -ELEMENTS[2369] = Fluid3D([15134,15505,15806,15339],0); -ELEMENTS[2370] = Fluid3D([15627,15134,15806,15492],0); -ELEMENTS[2371] = Fluid3D([15161,15505,14855,15129],0); -ELEMENTS[2372] = Fluid3D([15161,15505,15129,15570],0); -ELEMENTS[2373] = Fluid3D([15505,15129,15570,15455],0); -ELEMENTS[2374] = Fluid3D([15129,15570,15455,14799],0); -ELEMENTS[2375] = Fluid3D([15129,15570,14799,15159],0); -ELEMENTS[2376] = Fluid3D([15129,15570,15159,15161],0); -ELEMENTS[2377] = Fluid3D([14799,15129,15159,14315],0); -ELEMENTS[2378] = Fluid3D([15455,15129,14799,14855],0); -ELEMENTS[2379] = Fluid3D([15455,15129,14855,15505],0); -ELEMENTS[2380] = Fluid3D([15159,15129,15161,14315],0); -ELEMENTS[2381] = Fluid3D([14855,15161,15129,14315],0); -ELEMENTS[2382] = Fluid3D([15505,15627,15806,16125],0); -ELEMENTS[2383] = Fluid3D([15505,15627,16125,15697],0); -ELEMENTS[2384] = Fluid3D([15627,15806,16125,16151],0); -ELEMENTS[2385] = Fluid3D([15806,15505,16125,16030],0); -ELEMENTS[2386] = Fluid3D([15505,16125,16030,16016],0); -ELEMENTS[2387] = Fluid3D([15806,15505,16030,15339],0); -ELEMENTS[2388] = Fluid3D([16125,16030,16016,16504],0); -ELEMENTS[2389] = Fluid3D([16125,16030,16504,16428],0); -ELEMENTS[2390] = Fluid3D([16030,16016,16504,16192],0); -ELEMENTS[2391] = Fluid3D([16125,16030,16428,15806],0); -ELEMENTS[2392] = Fluid3D([16030,16504,16428,16576],0); -ELEMENTS[2393] = Fluid3D([16504,16428,16576,16900],0); -ELEMENTS[2394] = Fluid3D([16428,16576,16900,16729],0); -ELEMENTS[2395] = Fluid3D([16428,16576,16729,16213],0); -ELEMENTS[2396] = Fluid3D([16428,16576,16213,16030],0); -ELEMENTS[2397] = Fluid3D([16030,16016,16192,15455],0); -ELEMENTS[2398] = Fluid3D([16504,16428,16900,16713],0); -ELEMENTS[2399] = Fluid3D([16428,16900,16713,16865],0); -ELEMENTS[2400] = Fluid3D([16504,16428,16713,16125],0); -ELEMENTS[2401] = Fluid3D([16900,16713,16865,17217],0); -ELEMENTS[2402] = Fluid3D([16865,16900,17217,17221],0); -ELEMENTS[2403] = Fluid3D([16865,16900,17221,16729],0); -ELEMENTS[2404] = Fluid3D([16900,16713,17217,17014],0); -ELEMENTS[2405] = Fluid3D([16900,16713,17014,16504],0); -ELEMENTS[2406] = Fluid3D([16713,17217,17014,17046],0); -ELEMENTS[2407] = Fluid3D([17014,16713,17046,16667],0); -ELEMENTS[2408] = Fluid3D([17014,16713,16667,16504],0); -ELEMENTS[2409] = Fluid3D([16713,17217,17046,16967],0); -ELEMENTS[2410] = Fluid3D([16713,17217,16967,16865],0); -ELEMENTS[2411] = Fluid3D([17217,17046,16967,17379],0); -ELEMENTS[2412] = Fluid3D([16967,17217,17379,17333],0); -ELEMENTS[2413] = Fluid3D([16967,17217,17333,16865],0); -ELEMENTS[2414] = Fluid3D([17217,17046,17379,17470],0); -ELEMENTS[2415] = Fluid3D([17217,17046,17470,17014],0); -ELEMENTS[2416] = Fluid3D([17046,17379,17470,17417],0); -ELEMENTS[2417] = Fluid3D([17470,17046,17417,17163],0); -ELEMENTS[2418] = Fluid3D([17470,17046,17163,17014],0); -ELEMENTS[2419] = Fluid3D([17046,17379,17417,17134],0); -ELEMENTS[2420] = Fluid3D([17046,17379,17134,16967],0); -ELEMENTS[2421] = Fluid3D([17379,17417,17134,17549],0); -ELEMENTS[2422] = Fluid3D([17379,17417,17549,17722],0); -ELEMENTS[2423] = Fluid3D([17417,17134,17549,17363],0); -ELEMENTS[2424] = Fluid3D([17417,17134,17363,17031],0); -ELEMENTS[2425] = Fluid3D([17417,17134,17031,17046],0); -ELEMENTS[2426] = Fluid3D([17379,17417,17722,17470],0); -ELEMENTS[2427] = Fluid3D([16428,16900,16865,16729],0); -ELEMENTS[2428] = Fluid3D([16030,16504,16576,16192],0); -ELEMENTS[2429] = Fluid3D([16030,15505,16016,15455],0); -ELEMENTS[2430] = Fluid3D([15505,16125,16016,15697],0); -ELEMENTS[2431] = Fluid3D([16016,16504,16192,16459],0); -ELEMENTS[2432] = Fluid3D([14855,15505,15339,15455],0); -ELEMENTS[2433] = Fluid3D([17046,17417,17163,17031],0); -ELEMENTS[2434] = Fluid3D([16016,16125,16504,16667],0); -ELEMENTS[2435] = Fluid3D([17134,17379,17549,17311],0); -ELEMENTS[2436] = Fluid3D([17379,17549,17311,17720],0); -ELEMENTS[2437] = Fluid3D([17549,17311,17720,17641],0); -ELEMENTS[2438] = Fluid3D([17549,17134,17311,17288],0); -ELEMENTS[2439] = Fluid3D([17549,17134,17288,17363],0); -ELEMENTS[2440] = Fluid3D([17134,17379,17311,16967],0); -ELEMENTS[2441] = Fluid3D([17134,17311,17288,16918],0); -ELEMENTS[2442] = Fluid3D([17134,17311,16918,16967],0); -ELEMENTS[2443] = Fluid3D([17288,17134,16918,16860],0); -ELEMENTS[2444] = Fluid3D([17134,16918,16860,16650],0); -ELEMENTS[2445] = Fluid3D([16860,17134,16650,17031],0); -ELEMENTS[2446] = Fluid3D([17311,17288,16918,17219],0); -ELEMENTS[2447] = Fluid3D([17288,16918,17219,16979],0); -ELEMENTS[2448] = Fluid3D([17288,16918,16979,16860],0); -ELEMENTS[2449] = Fluid3D([17311,17288,17219,17641],0); -ELEMENTS[2450] = Fluid3D([17288,17134,16860,17363],0); -ELEMENTS[2451] = Fluid3D([17134,16918,16650,16967],0); -ELEMENTS[2452] = Fluid3D([17379,17549,17720,17722],0); -ELEMENTS[2453] = Fluid3D([17549,17311,17641,17288],0); -ELEMENTS[2454] = Fluid3D([17311,17720,17641,17554],0); -ELEMENTS[2455] = Fluid3D([17311,17720,17554,17333],0); -ELEMENTS[2456] = Fluid3D([17720,17641,17554,17866],0); -ELEMENTS[2457] = Fluid3D([17641,17554,17866,17606],0); -ELEMENTS[2458] = Fluid3D([17641,17311,17554,17219],0); -ELEMENTS[2459] = Fluid3D([17311,17379,17720,17333],0); -ELEMENTS[2460] = Fluid3D([17720,17549,17641,17887],0); -ELEMENTS[2461] = Fluid3D([17549,17641,17887,17730],0); -ELEMENTS[2462] = Fluid3D([17641,17887,17730,17973],0); -ELEMENTS[2463] = Fluid3D([17887,17730,17973,18070],0); -ELEMENTS[2464] = Fluid3D([17641,17887,17973,17866],0); -ELEMENTS[2465] = Fluid3D([17730,17641,17973,17726],0); -ELEMENTS[2466] = Fluid3D([17641,17720,17887,17866],0); -ELEMENTS[2467] = Fluid3D([17720,17549,17887,17722],0); -ELEMENTS[2468] = Fluid3D([17549,17641,17730,17288],0); -ELEMENTS[2469] = Fluid3D([17887,17549,17730,17813],0); -ELEMENTS[2470] = Fluid3D([17549,17730,17813,17363],0); -ELEMENTS[2471] = Fluid3D([17887,17549,17813,17722],0); -ELEMENTS[2472] = Fluid3D([17730,17887,17813,18070],0); -ELEMENTS[2473] = Fluid3D([16918,16860,16650,16414],0); -ELEMENTS[2474] = Fluid3D([16918,16860,16414,16979],0); -ELEMENTS[2475] = Fluid3D([16860,16650,16414,16445],0); -ELEMENTS[2476] = Fluid3D([16414,16860,16445,16280],0); -ELEMENTS[2477] = Fluid3D([16860,16650,16445,17031],0); -ELEMENTS[2478] = Fluid3D([16650,16414,16445,16098],0); -ELEMENTS[2479] = Fluid3D([16650,16918,16414,16338],0); -ELEMENTS[2480] = Fluid3D([16918,16414,16338,16599],0); -ELEMENTS[2481] = Fluid3D([16414,16338,16599,16053],0); -ELEMENTS[2482] = Fluid3D([16414,16338,16053,16098],0); -ELEMENTS[2483] = Fluid3D([16650,16918,16338,16967],0); -ELEMENTS[2484] = Fluid3D([16338,16599,16053,16198],0); -ELEMENTS[2485] = Fluid3D([16338,16599,16198,16786],0); -ELEMENTS[2486] = Fluid3D([16599,16198,16786,16666],0); -ELEMENTS[2487] = Fluid3D([16599,16053,16198,16182],0); -ELEMENTS[2488] = Fluid3D([16599,16198,16666,16182],0); -ELEMENTS[2489] = Fluid3D([16053,16198,16182,15680],0); -ELEMENTS[2490] = Fluid3D([16053,16198,15680,15683],0); -ELEMENTS[2491] = Fluid3D([16198,16182,15680,16057],0); -ELEMENTS[2492] = Fluid3D([16198,16182,16057,16666],0); -ELEMENTS[2493] = Fluid3D([16182,15680,16057,15686],0); -ELEMENTS[2494] = Fluid3D([15680,16057,15686,15434],0); -ELEMENTS[2495] = Fluid3D([15680,16057,15434,15794],0); -ELEMENTS[2496] = Fluid3D([15680,16057,15794,16198],0); -ELEMENTS[2497] = Fluid3D([16182,15680,15686,15715],0); -ELEMENTS[2498] = Fluid3D([15680,15686,15715,15115],0); -ELEMENTS[2499] = Fluid3D([15680,15686,15115,15434],0); -ELEMENTS[2500] = Fluid3D([16182,15680,15715,16053],0); -ELEMENTS[2501] = Fluid3D([16053,16338,16198,15683],0); -ELEMENTS[2502] = Fluid3D([16599,16053,16182,16327],0); -ELEMENTS[2503] = Fluid3D([16599,16053,16327,16414],0); -ELEMENTS[2504] = Fluid3D([16053,16182,16327,15715],0); -ELEMENTS[2505] = Fluid3D([16182,16599,16327,16660],0); -ELEMENTS[2506] = Fluid3D([16182,16599,16660,16666],0); -ELEMENTS[2507] = Fluid3D([16599,16327,16660,16979],0); -ELEMENTS[2508] = Fluid3D([16327,16182,16660,16171],0); -ELEMENTS[2509] = Fluid3D([16182,16660,16171,16430],0); -ELEMENTS[2510] = Fluid3D([16327,16182,16171,15715],0); -ELEMENTS[2511] = Fluid3D([16660,16171,16430,16627],0); -ELEMENTS[2512] = Fluid3D([16660,16171,16627,16601],0); -ELEMENTS[2513] = Fluid3D([16660,16171,16601,16327],0); -ELEMENTS[2514] = Fluid3D([16171,16430,16627,16242],0); -ELEMENTS[2515] = Fluid3D([16171,16430,16242,15686],0); -ELEMENTS[2516] = Fluid3D([16627,16171,16242,16255],0); -ELEMENTS[2517] = Fluid3D([16627,16171,16255,16601],0); -ELEMENTS[2518] = Fluid3D([16171,16242,16255,15704],0); -ELEMENTS[2519] = Fluid3D([16242,16255,15704,15880],0); -ELEMENTS[2520] = Fluid3D([16242,16255,15880,16653],0); -ELEMENTS[2521] = Fluid3D([16171,16242,15704,15686],0); -ELEMENTS[2522] = Fluid3D([16182,16660,16430,16666],0); -ELEMENTS[2523] = Fluid3D([16430,16627,16242,16688],0); -ELEMENTS[2524] = Fluid3D([16338,16599,16786,16918],0); -ELEMENTS[2525] = Fluid3D([16198,16786,16666,16481],0); -ELEMENTS[2526] = Fluid3D([16198,16786,16481,16425],0); -ELEMENTS[2527] = Fluid3D([16786,16666,16481,17028],0); -ELEMENTS[2528] = Fluid3D([16666,16481,17028,16819],0); -ELEMENTS[2529] = Fluid3D([16666,16481,16819,16057],0); -ELEMENTS[2530] = Fluid3D([16786,16481,16425,16897],0); -ELEMENTS[2531] = Fluid3D([16481,16425,16897,16379],0); -ELEMENTS[2532] = Fluid3D([16786,16481,16897,17028],0); -ELEMENTS[2533] = Fluid3D([16481,16425,16379,15794],0); -ELEMENTS[2534] = Fluid3D([16786,16666,17028,17219],0); -ELEMENTS[2535] = Fluid3D([16666,16198,16481,16057],0); -ELEMENTS[2536] = Fluid3D([16198,16786,16425,16338],0); -ELEMENTS[2537] = Fluid3D([16481,16198,16425,15794],0); -ELEMENTS[2538] = Fluid3D([16414,16650,16338,16098],0); -ELEMENTS[2539] = Fluid3D([16918,16414,16599,16979],0); -ELEMENTS[2540] = Fluid3D([15686,16182,15715,16171],0); -ELEMENTS[2541] = Fluid3D([16786,16599,16666,17219],0); -ELEMENTS[2542] = Fluid3D([16171,16182,16430,15686],0); -ELEMENTS[2543] = Fluid3D([14163,13917,14102,14398],0); -ELEMENTS[2544] = Fluid3D([14163,13917,14398,14157],0); -ELEMENTS[2545] = Fluid3D([14398,14163,14157,14722],0); -ELEMENTS[2546] = Fluid3D([14398,14163,14722,15054],0); -ELEMENTS[2547] = Fluid3D([14157,14398,14722,15056],0); -ELEMENTS[2548] = Fluid3D([13917,14398,14157,14468],0); -ELEMENTS[2549] = Fluid3D([14102,14163,14398,14759],0); -ELEMENTS[2550] = Fluid3D([13917,14398,14468,14102],0); -ELEMENTS[2551] = Fluid3D([14398,14722,15056,15010],0); -ELEMENTS[2552] = Fluid3D([13368,13975,13494,13161],0); -ELEMENTS[2553] = Fluid3D([13368,13975,13161,13691],0); -ELEMENTS[2554] = Fluid3D([13494,13368,13161,12751],0); -ELEMENTS[2555] = Fluid3D([13494,13368,12751,13249],0); -ELEMENTS[2556] = Fluid3D([13161,13494,12751,12496],0); -ELEMENTS[2557] = Fluid3D([13975,13494,13161,13720],0); -ELEMENTS[2558] = Fluid3D([13368,13161,12751,12612],0); -ELEMENTS[2559] = Fluid3D([13494,13975,14315,13720],0); -ELEMENTS[2560] = Fluid3D([14103,14613,14469,13691],0); -ELEMENTS[2561] = Fluid3D([14102,13494,14315,13891],0); -ELEMENTS[2562] = Fluid3D([14102,13494,13891,13249],0); -ELEMENTS[2563] = Fluid3D([14918,14103,14469,14426],0); -ELEMENTS[2564] = Fluid3D([14469,14918,14426,15075],0); -ELEMENTS[2565] = Fluid3D([14918,14103,14426,14507],0); -ELEMENTS[2566] = Fluid3D([14918,14426,15075,15126],0); -ELEMENTS[2567] = Fluid3D([14918,14426,15126,14507],0); -ELEMENTS[2568] = Fluid3D([15075,14918,15126,15669],0); -ELEMENTS[2569] = Fluid3D([15075,14918,15669,15346],0); -ELEMENTS[2570] = Fluid3D([14918,15126,15669,15277],0); -ELEMENTS[2571] = Fluid3D([14426,15075,15126,14879],0); -ELEMENTS[2572] = Fluid3D([15126,14426,14879,14549],0); -ELEMENTS[2573] = Fluid3D([14426,14879,14549,14063],0); -ELEMENTS[2574] = Fluid3D([14426,15075,14879,14445],0); -ELEMENTS[2575] = Fluid3D([14426,14879,14063,14445],0); -ELEMENTS[2576] = Fluid3D([14426,15075,14445,14469],0); -ELEMENTS[2577] = Fluid3D([15075,14879,14445,15168],0); -ELEMENTS[2578] = Fluid3D([14879,14445,15168,15046],0); -ELEMENTS[2579] = Fluid3D([15075,14879,15168,15557],0); -ELEMENTS[2580] = Fluid3D([14879,15168,15557,15046],0); -ELEMENTS[2581] = Fluid3D([15075,14879,15557,15126],0); -ELEMENTS[2582] = Fluid3D([15168,15075,15557,15637],0); -ELEMENTS[2583] = Fluid3D([15168,15075,15637,15022],0); -ELEMENTS[2584] = Fluid3D([15168,15075,15022,14445],0); -ELEMENTS[2585] = Fluid3D([15075,15557,15637,15669],0); -ELEMENTS[2586] = Fluid3D([15075,15637,15022,15346],0); -ELEMENTS[2587] = Fluid3D([15126,14426,14549,14507],0); -ELEMENTS[2588] = Fluid3D([14879,14549,14063,14366],0); -ELEMENTS[2589] = Fluid3D([14549,14063,14366,13565],0); -ELEMENTS[2590] = Fluid3D([14366,14549,13565,14332],0); -ELEMENTS[2591] = Fluid3D([14549,14063,13565,13349],0); -ELEMENTS[2592] = Fluid3D([15557,15168,15637,15818],0); -ELEMENTS[2593] = Fluid3D([15557,15168,15818,15046],0); -ELEMENTS[2594] = Fluid3D([15168,15637,15818,15535],0); -ELEMENTS[2595] = Fluid3D([15168,15637,15535,15022],0); -ELEMENTS[2596] = Fluid3D([15818,15168,15535,15046],0); -ELEMENTS[2597] = Fluid3D([15637,15557,15818,16140],0); -ELEMENTS[2598] = Fluid3D([15637,15557,16140,15669],0); -ELEMENTS[2599] = Fluid3D([15557,15818,16140,16131],0); -ELEMENTS[2600] = Fluid3D([15818,16140,16131,16397],0); -ELEMENTS[2601] = Fluid3D([16131,15818,16397,16058],0); -ELEMENTS[2602] = Fluid3D([15818,16140,16397,16134],0); -ELEMENTS[2603] = Fluid3D([15818,16140,16134,15637],0); -ELEMENTS[2604] = Fluid3D([16131,15818,16058,15639],0); -ELEMENTS[2605] = Fluid3D([15818,16058,15639,15732],0); -ELEMENTS[2606] = Fluid3D([16058,16131,15639,16123],0); -ELEMENTS[2607] = Fluid3D([15639,16058,16123,16015],0); -ELEMENTS[2608] = Fluid3D([15639,16058,16015,15901],0); -ELEMENTS[2609] = Fluid3D([16058,16123,16015,16461],0); -ELEMENTS[2610] = Fluid3D([16058,16015,15901,16461],0); -ELEMENTS[2611] = Fluid3D([16015,15901,16461,16080],0); -ELEMENTS[2612] = Fluid3D([16015,15901,16080,15543],0); -ELEMENTS[2613] = Fluid3D([16123,15639,16015,15543],0); -ELEMENTS[2614] = Fluid3D([16058,16131,16123,16528],0); -ELEMENTS[2615] = Fluid3D([16123,16058,16528,16461],0); -ELEMENTS[2616] = Fluid3D([16461,16015,16080,16319],0); -ELEMENTS[2617] = Fluid3D([16461,16015,16319,16123],0); -ELEMENTS[2618] = Fluid3D([16058,16131,16528,16397],0); -ELEMENTS[2619] = Fluid3D([16528,16058,16397,16326],0); -ELEMENTS[2620] = Fluid3D([16131,16528,16397,16648],0); -ELEMENTS[2621] = Fluid3D([16528,16397,16648,16856],0); -ELEMENTS[2622] = Fluid3D([16528,16397,16856,16837],0); -ELEMENTS[2623] = Fluid3D([16397,16648,16856,16690],0); -ELEMENTS[2624] = Fluid3D([16648,16528,16856,17008],0); -ELEMENTS[2625] = Fluid3D([16856,16397,16690,16701],0); -ELEMENTS[2626] = Fluid3D([16856,16397,16701,16837],0); -ELEMENTS[2627] = Fluid3D([16397,16648,16690,16140],0); -ELEMENTS[2628] = Fluid3D([16528,16856,17008,16837],0); -ELEMENTS[2629] = Fluid3D([16648,16528,17008,16544],0); -ELEMENTS[2630] = Fluid3D([16397,16131,16648,16140],0); -ELEMENTS[2631] = Fluid3D([16648,16856,16690,17026],0); -ELEMENTS[2632] = Fluid3D([16856,16690,17026,17042],0); -ELEMENTS[2633] = Fluid3D([16690,16648,17026,16654],0); -ELEMENTS[2634] = Fluid3D([16690,16648,16654,16140],0); -ELEMENTS[2635] = Fluid3D([16856,16648,17008,17026],0); -ELEMENTS[2636] = Fluid3D([17026,16690,16654,16982],0); -ELEMENTS[2637] = Fluid3D([17026,16690,16982,17042],0); -ELEMENTS[2638] = Fluid3D([16690,16654,16982,16613],0); -ELEMENTS[2639] = Fluid3D([16982,16690,16613,16952],0); -ELEMENTS[2640] = Fluid3D([16015,15639,15901,15543],0); -ELEMENTS[2641] = Fluid3D([16654,17026,16982,16857],0); -ELEMENTS[2642] = Fluid3D([16648,17026,16654,16936],0); -ELEMENTS[2643] = Fluid3D([17026,16654,16936,16857],0); -ELEMENTS[2644] = Fluid3D([16654,16936,16857,16432],0); -ELEMENTS[2645] = Fluid3D([16648,17026,16936,17008],0); -ELEMENTS[2646] = Fluid3D([16654,16648,16936,16317],0); -ELEMENTS[2647] = Fluid3D([16654,16648,16317,16140],0); -ELEMENTS[2648] = Fluid3D([16648,16936,16317,16548],0); -ELEMENTS[2649] = Fluid3D([16317,16648,16548,16131],0); -ELEMENTS[2650] = Fluid3D([16648,16936,16548,17008],0); -ELEMENTS[2651] = Fluid3D([16936,16654,16317,16432],0); -ELEMENTS[2652] = Fluid3D([16936,16317,16548,16756],0); -ELEMENTS[2653] = Fluid3D([16690,16654,16613,16140],0); -ELEMENTS[2654] = Fluid3D([15557,15818,16131,15639],0); -ELEMENTS[2655] = Fluid3D([15637,15818,15535,16134],0); -ELEMENTS[2656] = Fluid3D([16140,15557,16131,16317],0); -ELEMENTS[2657] = Fluid3D([16654,16982,16613,16717],0); -ELEMENTS[2658] = Fluid3D([14103,14469,14426,13718],0); -ELEMENTS[2659] = Fluid3D([14469,14426,13718,14445],0); -ELEMENTS[2660] = Fluid3D([14426,14103,13718,13349],0); -ELEMENTS[2661] = Fluid3D([14103,14469,13718,13691],0); -ELEMENTS[2662] = Fluid3D([14879,15126,14549,14997],0); -ELEMENTS[2663] = Fluid3D([15126,14549,14997,14851],0); -ELEMENTS[2664] = Fluid3D([14549,14997,14851,14332],0); -ELEMENTS[2665] = Fluid3D([14549,14997,14332,14366],0); -ELEMENTS[2666] = Fluid3D([14549,14997,14366,14879],0); -ELEMENTS[2667] = Fluid3D([15126,14549,14851,14507],0); -ELEMENTS[2668] = Fluid3D([15818,16397,16058,16161],0); -ELEMENTS[2669] = Fluid3D([14469,14918,15075,15346],0); -ELEMENTS[2670] = Fluid3D([15126,15075,15669,15557],0); -ELEMENTS[2671] = Fluid3D([14549,14426,14063,13349],0); -ELEMENTS[2672] = Fluid3D([16140,16397,16134,16690],0); -ELEMENTS[2673] = Fluid3D([17054,16875,17307,17263],0); -ELEMENTS[2674] = Fluid3D([17307,17054,17263,17489],0); -ELEMENTS[2675] = Fluid3D([17054,16875,17263,16761],0); -ELEMENTS[2676] = Fluid3D([17054,17263,17489,17331],0); -ELEMENTS[2677] = Fluid3D([17489,17054,17331,17249],0); -ELEMENTS[2678] = Fluid3D([17054,17263,17331,16761],0); -ELEMENTS[2679] = Fluid3D([17331,17489,17249,17596],0); -ELEMENTS[2680] = Fluid3D([17331,17489,17596,17648],0); -ELEMENTS[2681] = Fluid3D([17331,17489,17648,17263],0); -ELEMENTS[2682] = Fluid3D([17489,17249,17596,17614],0); -ELEMENTS[2683] = Fluid3D([17249,17596,17614,17431],0); -ELEMENTS[2684] = Fluid3D([17596,17614,17431,17859],0); -ELEMENTS[2685] = Fluid3D([17249,17596,17431,17293],0); -ELEMENTS[2686] = Fluid3D([17596,17614,17859,17867],0); -ELEMENTS[2687] = Fluid3D([17431,17249,17293,17031],0); -ELEMENTS[2688] = Fluid3D([17489,17249,17614,17312],0); -ELEMENTS[2689] = Fluid3D([17489,17249,17312,17054],0); -ELEMENTS[2690] = Fluid3D([17249,17614,17312,17363],0); -ELEMENTS[2691] = Fluid3D([17249,17614,17363,17431],0); -ELEMENTS[2692] = Fluid3D([17312,17249,17363,16860],0); -ELEMENTS[2693] = Fluid3D([17614,17312,17363,17730],0); -ELEMENTS[2694] = Fluid3D([17363,17249,17431,17031],0); -ELEMENTS[2695] = Fluid3D([17614,17363,17431,17813],0); -ELEMENTS[2696] = Fluid3D([17363,17249,17031,16860],0); -ELEMENTS[2697] = Fluid3D([17614,17363,17813,17730],0); -ELEMENTS[2698] = Fluid3D([17813,17614,17730,18070],0); -ELEMENTS[2699] = Fluid3D([17249,17596,17293,17331],0); -ELEMENTS[2700] = Fluid3D([17596,17614,17867,17489],0); -ELEMENTS[2701] = Fluid3D([17614,17431,17859,17813],0); -ELEMENTS[2702] = Fluid3D([17859,17614,17813,18070],0); -ELEMENTS[2703] = Fluid3D([17489,17596,17648,17867],0); -ELEMENTS[2704] = Fluid3D([16875,17307,17263,17316],0); -ELEMENTS[2705] = Fluid3D([17307,17263,17316,17633],0); -ELEMENTS[2706] = Fluid3D([16875,17307,17316,17040],0); -ELEMENTS[2707] = Fluid3D([17263,17316,17633,17542],0); -ELEMENTS[2708] = Fluid3D([17263,16875,17316,17065],0); -ELEMENTS[2709] = Fluid3D([17263,17316,17542,17065],0); -ELEMENTS[2710] = Fluid3D([17633,17263,17542,17648],0); -ELEMENTS[2711] = Fluid3D([17263,16875,17065,16761],0); -ELEMENTS[2712] = Fluid3D([17307,17263,17633,17489],0); -ELEMENTS[2713] = Fluid3D([17316,17307,17633,17579],0); -ELEMENTS[2714] = Fluid3D([17316,17633,17542,17729],0); -ELEMENTS[2715] = Fluid3D([16875,17316,17065,17038],0); -ELEMENTS[2716] = Fluid3D([16875,17316,17038,17040],0); -ELEMENTS[2717] = Fluid3D([17316,17065,17038,17032],0); -ELEMENTS[2718] = Fluid3D([17065,17038,17032,16800],0); -ELEMENTS[2719] = Fluid3D([17032,17065,16800,17487],0); -ELEMENTS[2720] = Fluid3D([17065,17038,16800,16696],0); -ELEMENTS[2721] = Fluid3D([17065,17038,16696,16875],0); -ELEMENTS[2722] = Fluid3D([17038,16696,16875,16574],0); -ELEMENTS[2723] = Fluid3D([17038,16800,16696,17032],0); -ELEMENTS[2724] = Fluid3D([16696,17038,17032,16689],0); -ELEMENTS[2725] = Fluid3D([16696,17038,16689,16446],0); -ELEMENTS[2726] = Fluid3D([16696,17038,16446,16574],0); -ELEMENTS[2727] = Fluid3D([16800,17065,16696,16875],0); -ELEMENTS[2728] = Fluid3D([17038,17032,16689,17182],0); -ELEMENTS[2729] = Fluid3D([17038,17032,17182,17316],0); -ELEMENTS[2730] = Fluid3D([16689,17038,17182,16446],0); -ELEMENTS[2731] = Fluid3D([17859,17596,17867,17929],0); -ELEMENTS[2732] = Fluid3D([17867,17859,17929,18152],0); -ELEMENTS[2733] = Fluid3D([17859,17929,18152,18129],0); -ELEMENTS[2734] = Fluid3D([17859,17929,18129,17769],0); -ELEMENTS[2735] = Fluid3D([17929,18129,17769,17998],0); -ELEMENTS[2736] = Fluid3D([17929,18129,17998,18188],0); -ELEMENTS[2737] = Fluid3D([18129,17998,18188,18234],0); -ELEMENTS[2738] = Fluid3D([18129,17998,18234,18012],0); -ELEMENTS[2739] = Fluid3D([17859,17596,17929,17769],0); -ELEMENTS[2740] = Fluid3D([18129,17998,18012,17769],0); -ELEMENTS[2741] = Fluid3D([17929,18129,18188,18152],0); -ELEMENTS[2742] = Fluid3D([17867,17859,18152,18070],0); -ELEMENTS[2743] = Fluid3D([17596,17867,17929,17648],0); -ELEMENTS[2744] = Fluid3D([17929,17867,18152,18163],0); -ELEMENTS[2745] = Fluid3D([17867,18152,18163,18070],0); -ELEMENTS[2746] = Fluid3D([18129,17859,17769,17884],0); -ELEMENTS[2747] = Fluid3D([18129,17859,17884,18096],0); -ELEMENTS[2748] = Fluid3D([17859,17884,18096,17813],0); -ELEMENTS[2749] = Fluid3D([17769,18129,17884,18012],0); -ELEMENTS[2750] = Fluid3D([17884,18129,18096,18183],0); -ELEMENTS[2751] = Fluid3D([18096,17884,18183,18038],0); -ELEMENTS[2752] = Fluid3D([17884,18129,18183,18012],0); -ELEMENTS[2753] = Fluid3D([18129,18096,18183,18410],0); -ELEMENTS[2754] = Fluid3D([17884,18183,18038,17979],0); -ELEMENTS[2755] = Fluid3D([17884,18183,17979,18012],0); -ELEMENTS[2756] = Fluid3D([18183,18038,17979,18213],0); -ELEMENTS[2757] = Fluid3D([18183,18038,18213,18294],0); -ELEMENTS[2758] = Fluid3D([18038,18213,18294,18207],0); -ELEMENTS[2759] = Fluid3D([18038,17979,18213,17996],0); -ELEMENTS[2760] = Fluid3D([18038,17979,17996,17787],0); -ELEMENTS[2761] = Fluid3D([18038,17884,17979,17787],0); -ELEMENTS[2762] = Fluid3D([18183,18038,18294,18096],0); -ELEMENTS[2763] = Fluid3D([18038,18213,18207,17996],0); -ELEMENTS[2764] = Fluid3D([18096,17884,18038,17813],0); -ELEMENTS[2765] = Fluid3D([18129,17859,18096,18152],0); -ELEMENTS[2766] = Fluid3D([17859,17769,17884,17431],0); -ELEMENTS[2767] = Fluid3D([18213,18183,18294,18375],0); -ELEMENTS[2768] = Fluid3D([18183,18294,18375,18410],0); -ELEMENTS[2769] = Fluid3D([18294,18213,18375,18417],0); -ELEMENTS[2770] = Fluid3D([18294,18213,18417,18207],0); -ELEMENTS[2771] = Fluid3D([18375,18294,18417,18479],0); -ELEMENTS[2772] = Fluid3D([18417,18375,18479,18575],0); -ELEMENTS[2773] = Fluid3D([18213,18183,18375,18230],0); -ELEMENTS[2774] = Fluid3D([18183,18375,18230,18314],0); -ELEMENTS[2775] = Fluid3D([18375,18230,18314,18426],0); -ELEMENTS[2776] = Fluid3D([18213,18183,18230,17979],0); -ELEMENTS[2777] = Fluid3D([18314,18375,18426,18527],0); -ELEMENTS[2778] = Fluid3D([18183,18375,18314,18410],0); -ELEMENTS[2779] = Fluid3D([18375,18230,18426,18388],0); -ELEMENTS[2780] = Fluid3D([18375,18230,18388,18213],0); -ELEMENTS[2781] = Fluid3D([18230,18426,18388,18336],0); -ELEMENTS[2782] = Fluid3D([18230,18426,18336,18278],0); -ELEMENTS[2783] = Fluid3D([18336,18230,18278,18103],0); -ELEMENTS[2784] = Fluid3D([18230,18426,18278,18314],0); -ELEMENTS[2785] = Fluid3D([18336,18230,18103,18172],0); -ELEMENTS[2786] = Fluid3D([18336,18230,18172,18388],0); -ELEMENTS[2787] = Fluid3D([18230,18103,18172,17979],0); -ELEMENTS[2788] = Fluid3D([18426,18388,18336,18501],0); -ELEMENTS[2789] = Fluid3D([18426,18388,18501,18522],0); -ELEMENTS[2790] = Fluid3D([18388,18336,18501,18407],0); -ELEMENTS[2791] = Fluid3D([18388,18336,18407,18172],0); -ELEMENTS[2792] = Fluid3D([18388,18501,18522,18524],0); -ELEMENTS[2793] = Fluid3D([18388,18501,18524,18407],0); -ELEMENTS[2794] = Fluid3D([18501,18522,18524,18602],0); -ELEMENTS[2795] = Fluid3D([18524,18501,18602,18561],0); -ELEMENTS[2796] = Fluid3D([18524,18501,18561,18407],0); -ELEMENTS[2797] = Fluid3D([18501,18522,18602,18566],0); -ELEMENTS[2798] = Fluid3D([18501,18522,18566,18426],0); -ELEMENTS[2799] = Fluid3D([18522,18602,18566,18635],0); -ELEMENTS[2800] = Fluid3D([18602,18566,18635,18631],0); -ELEMENTS[2801] = Fluid3D([18635,18602,18631,18663],0); -ELEMENTS[2802] = Fluid3D([18635,18602,18663,18609],0); -ELEMENTS[2803] = Fluid3D([18522,18602,18635,18609],0); -ELEMENTS[2804] = Fluid3D([18602,18566,18631,18501],0); -ELEMENTS[2805] = Fluid3D([18426,18375,18388,18522],0); -ELEMENTS[2806] = Fluid3D([18336,18501,18407,18450],0); -ELEMENTS[2807] = Fluid3D([18336,18501,18450,18437],0); -ELEMENTS[2808] = Fluid3D([18501,18407,18450,18561],0); -ELEMENTS[2809] = Fluid3D([18407,18336,18450,18269],0); -ELEMENTS[2810] = Fluid3D([18407,18336,18269,18172],0); -ELEMENTS[2811] = Fluid3D([18336,18450,18269,18302],0); -ELEMENTS[2812] = Fluid3D([18269,18336,18302,18103],0); -ELEMENTS[2813] = Fluid3D([18336,18450,18302,18437],0); -ELEMENTS[2814] = Fluid3D([18450,18269,18302,18371],0); -ELEMENTS[2815] = Fluid3D([18269,18302,18371,18102],0); -ELEMENTS[2816] = Fluid3D([18302,18450,18371,18478],0); -ELEMENTS[2817] = Fluid3D([18450,18269,18371,18411],0); -ELEMENTS[2818] = Fluid3D([18450,18269,18411,18407],0); -ELEMENTS[2819] = Fluid3D([18269,18371,18411,18224],0); -ELEMENTS[2820] = Fluid3D([18411,18269,18224,18264],0); -ELEMENTS[2821] = Fluid3D([18269,18371,18224,18102],0); -ELEMENTS[2822] = Fluid3D([18411,18269,18264,18407],0); -ELEMENTS[2823] = Fluid3D([18371,18411,18224,18399],0); -ELEMENTS[2824] = Fluid3D([18411,18224,18399,18363],0); -ELEMENTS[2825] = Fluid3D([18224,18371,18399,18212],0); -ELEMENTS[2826] = Fluid3D([18224,18371,18212,18102],0); -ELEMENTS[2827] = Fluid3D([18371,18411,18399,18535],0); -ELEMENTS[2828] = Fluid3D([18411,18399,18535,18520],0); -ELEMENTS[2829] = Fluid3D([18411,18399,18520,18363],0); -ELEMENTS[2830] = Fluid3D([18371,18411,18535,18450],0); -ELEMENTS[2831] = Fluid3D([18411,18224,18363,18264],0); -ELEMENTS[2832] = Fluid3D([18269,18302,18102,18103],0); -ELEMENTS[2833] = Fluid3D([18224,18399,18363,18238],0); -ELEMENTS[2834] = Fluid3D([18363,18224,18238,18130],0); -ELEMENTS[2835] = Fluid3D([18224,18399,18238,18212],0); -ELEMENTS[2836] = Fluid3D([18224,18238,18130,18007],0); -ELEMENTS[2837] = Fluid3D([18238,18130,18007,17930],0); -ELEMENTS[2838] = Fluid3D([18238,18130,17930,18252],0); -ELEMENTS[2839] = Fluid3D([18238,18130,18252,18363],0); -ELEMENTS[2840] = Fluid3D([18224,18238,18007,18212],0); -ELEMENTS[2841] = Fluid3D([18363,18224,18130,18264],0); -ELEMENTS[2842] = Fluid3D([18399,18363,18238,18429],0); -ELEMENTS[2843] = Fluid3D([18399,18363,18429,18520],0); -ELEMENTS[2844] = Fluid3D([18363,18238,18429,18252],0); -ELEMENTS[2845] = Fluid3D([18238,18399,18429,18368],0); -ELEMENTS[2846] = Fluid3D([18238,18399,18368,18212],0); -ELEMENTS[2847] = Fluid3D([18399,18429,18368,18518],0); -ELEMENTS[2848] = Fluid3D([18368,18399,18518,18401],0); -ELEMENTS[2849] = Fluid3D([18399,18429,18518,18520],0); -ELEMENTS[2850] = Fluid3D([18429,18368,18518,18485],0); -ELEMENTS[2851] = Fluid3D([18368,18518,18485,18453],0); -ELEMENTS[2852] = Fluid3D([18429,18368,18485,18333],0); -ELEMENTS[2853] = Fluid3D([18368,18485,18333,18380],0); -ELEMENTS[2854] = Fluid3D([18368,18485,18380,18453],0); -ELEMENTS[2855] = Fluid3D([18518,18429,18485,18578],0); -ELEMENTS[2856] = Fluid3D([18518,18429,18578,18520],0); -ELEMENTS[2857] = Fluid3D([18429,18485,18578,18472],0); -ELEMENTS[2858] = Fluid3D([18485,18578,18472,18583],0); -ELEMENTS[2859] = Fluid3D([18429,18485,18472,18333],0); -ELEMENTS[2860] = Fluid3D([18485,18578,18583,18608],0); -ELEMENTS[2861] = Fluid3D([18485,18578,18608,18518],0); -ELEMENTS[2862] = Fluid3D([18578,18583,18608,18662],0); -ELEMENTS[2863] = Fluid3D([18429,18368,18333,18238],0); -ELEMENTS[2864] = Fluid3D([18213,18375,18417,18388],0); -ELEMENTS[2865] = Fluid3D([18230,18183,18314,18012],0); -ELEMENTS[2866] = Fluid3D([18583,18485,18608,18585],0); -ELEMENTS[2867] = Fluid3D([18336,18426,18501,18437],0); -ELEMENTS[2868] = Fluid3D([18294,18417,18479,18422],0); -ELEMENTS[2869] = Fluid3D([18417,18479,18422,18533],0); -ELEMENTS[2870] = Fluid3D([18422,18417,18533,18492],0); -ELEMENTS[2871] = Fluid3D([18417,18479,18533,18575],0); -ELEMENTS[2872] = Fluid3D([18426,18336,18278,18437],0); -ELEMENTS[2873] = Fluid3D([18230,18278,18103,18012],0); -ELEMENTS[2874] = Fluid3D([17998,18188,18234,18145],0); -ELEMENTS[2875] = Fluid3D([17998,18188,18145,18095],0); -ELEMENTS[2876] = Fluid3D([18234,17998,18145,18186],0); -ELEMENTS[2877] = Fluid3D([18103,18336,18172,18269],0); -ELEMENTS[2878] = Fluid3D([17769,17929,17998,17705],0); -ELEMENTS[2879] = Fluid3D([17929,17998,17705,18095],0); -ELEMENTS[2880] = Fluid3D([17769,17929,17705,17596],0); -ELEMENTS[2881] = Fluid3D([17998,17769,17705,17727],0); -ELEMENTS[2882] = Fluid3D([17705,17998,17727,17923],0); -ELEMENTS[2883] = Fluid3D([17769,17705,17727,17293],0); -ELEMENTS[2884] = Fluid3D([17998,17769,17727,18012],0); -ELEMENTS[2885] = Fluid3D([17307,17054,17489,17312],0); -ELEMENTS[2886] = Fluid3D([17431,17596,17859,17769],0); -ELEMENTS[2887] = Fluid3D([17054,17331,17249,16921],0); -ELEMENTS[2888] = Fluid3D([17331,17249,16921,17293],0); -ELEMENTS[2889] = Fluid3D([17054,17331,16921,16761],0); -ELEMENTS[2890] = Fluid3D([17249,17054,16921,16863],0); -ELEMENTS[2891] = Fluid3D([17249,17054,16863,17312],0); -ELEMENTS[2892] = Fluid3D([16921,17249,16863,17031],0); -ELEMENTS[2893] = Fluid3D([17054,16921,16863,16583],0); -ELEMENTS[2894] = Fluid3D([17596,17331,17648,17705],0); -ELEMENTS[2895] = Fluid3D([16397,15818,16134,16161],0); -ELEMENTS[2896] = Fluid3D([17596,17431,17293,17769],0); -ELEMENTS[2897] = Fluid3D([17998,18234,18012,18186],0); -ELEMENTS[2898] = Fluid3D([14102,14315,14759,15008],0); -ELEMENTS[2899] = Fluid3D([17614,17859,17867,18070],0); -ELEMENTS[2900] = Fluid3D([16712,16655,17087,16848],0); -ELEMENTS[2901] = Fluid3D([17087,16712,16848,17224],0); -ELEMENTS[2902] = Fluid3D([16655,17087,16848,17017],0); -ELEMENTS[2903] = Fluid3D([16712,16655,16848,16348],0); -ELEMENTS[2904] = Fluid3D([16655,17087,17017,17097],0); -ELEMENTS[2905] = Fluid3D([16848,16655,17017,16557],0); -ELEMENTS[2906] = Fluid3D([16848,16655,16557,16348],0); -ELEMENTS[2907] = Fluid3D([16655,17017,16557,16669],0); -ELEMENTS[2908] = Fluid3D([17017,16557,16669,16866],0); -ELEMENTS[2909] = Fluid3D([16557,16669,16866,16349],0); -ELEMENTS[2910] = Fluid3D([16557,16669,16349,16157],0); -ELEMENTS[2911] = Fluid3D([16557,16669,16157,16655],0); -ELEMENTS[2912] = Fluid3D([16669,16349,16157,16231],0); -ELEMENTS[2913] = Fluid3D([16349,16157,16231,15780],0); -ELEMENTS[2914] = Fluid3D([16349,16157,15780,15974],0); -ELEMENTS[2915] = Fluid3D([16349,16157,15974,16557],0); -ELEMENTS[2916] = Fluid3D([16669,16349,16231,16661],0); -ELEMENTS[2917] = Fluid3D([16349,16231,16661,16147],0); -ELEMENTS[2918] = Fluid3D([16661,16349,16147,16546],0); -ELEMENTS[2919] = Fluid3D([16661,16349,16546,16866],0); -ELEMENTS[2920] = Fluid3D([16848,16712,16348,16595],0); -ELEMENTS[2921] = Fluid3D([16848,16712,16595,17224],0); -ELEMENTS[2922] = Fluid3D([16712,16348,16595,16331],0); -ELEMENTS[2923] = Fluid3D([16349,16231,16147,15780],0); -ELEMENTS[2924] = Fluid3D([16669,16349,16661,16866],0); -ELEMENTS[2925] = Fluid3D([16655,17017,16669,17097],0); -ELEMENTS[2926] = Fluid3D([17017,16557,16866,16971],0); -ELEMENTS[2927] = Fluid3D([17017,16557,16971,16848],0); -ELEMENTS[2928] = Fluid3D([16557,16866,16971,16565],0); -ELEMENTS[2929] = Fluid3D([16971,16557,16565,16542],0); -ELEMENTS[2930] = Fluid3D([16565,16971,16542,16846],0); -ELEMENTS[2931] = Fluid3D([16542,16565,16846,16315],0); -ELEMENTS[2932] = Fluid3D([16542,16565,16315,15974],0); -ELEMENTS[2933] = Fluid3D([16557,16866,16565,16349],0); -ELEMENTS[2934] = Fluid3D([16971,16557,16542,16848],0); -ELEMENTS[2935] = Fluid3D([16565,16971,16846,17024],0); -ELEMENTS[2936] = Fluid3D([16565,16971,17024,16866],0); -ELEMENTS[2937] = Fluid3D([16971,16846,17024,17275],0); -ELEMENTS[2938] = Fluid3D([16971,16846,17275,17035],0); -ELEMENTS[2939] = Fluid3D([17024,16971,17275,17338],0); -ELEMENTS[2940] = Fluid3D([17024,16971,17338,16866],0); -ELEMENTS[2941] = Fluid3D([16971,16846,17035,16542],0); -ELEMENTS[2942] = Fluid3D([16846,17024,17275,17141],0); -ELEMENTS[2943] = Fluid3D([17275,16846,17141,17154],0); -ELEMENTS[2944] = Fluid3D([17024,17275,17141,17536],0); -ELEMENTS[2945] = Fluid3D([17024,17275,17536,17338],0); -ELEMENTS[2946] = Fluid3D([16846,17024,17141,16704],0); -ELEMENTS[2947] = Fluid3D([17024,17141,16704,17140],0); -ELEMENTS[2948] = Fluid3D([16846,17024,16704,16565],0); -ELEMENTS[2949] = Fluid3D([17024,17141,17140,17536],0); -ELEMENTS[2950] = Fluid3D([17275,16846,17154,17035],0); -ELEMENTS[2951] = Fluid3D([16557,16565,16542,15974],0); -ELEMENTS[2952] = Fluid3D([16846,16542,16315,16573],0); -ELEMENTS[2953] = Fluid3D([16846,16542,16573,17035],0); -ELEMENTS[2954] = Fluid3D([16542,16315,16573,16086],0); -ELEMENTS[2955] = Fluid3D([16315,16846,16573,16619],0); -ELEMENTS[2956] = Fluid3D([16846,16573,16619,17154],0); -ELEMENTS[2957] = Fluid3D([16315,16573,16086,16102],0); -ELEMENTS[2958] = Fluid3D([16315,16573,16102,16619],0); -ELEMENTS[2959] = Fluid3D([16573,16086,16102,16215],0); -ELEMENTS[2960] = Fluid3D([16102,16573,16215,16514],0); -ELEMENTS[2961] = Fluid3D([16102,16573,16514,16619],0); -ELEMENTS[2962] = Fluid3D([16573,16086,16215,16485],0); -ELEMENTS[2963] = Fluid3D([16573,16086,16485,16542],0); -ELEMENTS[2964] = Fluid3D([16086,16215,16485,15931],0); -ELEMENTS[2965] = Fluid3D([16215,16485,15931,16355],0); -ELEMENTS[2966] = Fluid3D([16086,16215,15931,15617],0); -ELEMENTS[2967] = Fluid3D([16086,16215,15617,16102],0); -ELEMENTS[2968] = Fluid3D([16215,16485,16355,16767],0); -ELEMENTS[2969] = Fluid3D([16355,16215,16767,16488],0); -ELEMENTS[2970] = Fluid3D([16215,16485,16767,16573],0); -ELEMENTS[2971] = Fluid3D([16355,16215,16488,15854],0); -ELEMENTS[2972] = Fluid3D([16215,16488,15854,16035],0); -ELEMENTS[2973] = Fluid3D([16355,16215,15854,15931],0); -ELEMENTS[2974] = Fluid3D([16215,16488,16035,16514],0); -ELEMENTS[2975] = Fluid3D([16315,16846,16619,16704],0); -ELEMENTS[2976] = Fluid3D([16542,16315,16086,15974],0); -ELEMENTS[2977] = Fluid3D([16086,16315,16102,15712],0); -ELEMENTS[2978] = Fluid3D([16315,16102,15712,16013],0); -ELEMENTS[2979] = Fluid3D([16102,16086,15712,15617],0); -ELEMENTS[2980] = Fluid3D([16086,16315,15712,15974],0); -ELEMENTS[2981] = Fluid3D([16102,15712,16013,15536],0); -ELEMENTS[2982] = Fluid3D([16102,15712,15536,15617],0); -ELEMENTS[2983] = Fluid3D([16013,16102,15536,16069],0); -ELEMENTS[2984] = Fluid3D([16013,16102,16069,16619],0); -ELEMENTS[2985] = Fluid3D([16102,15536,16069,15815],0); -ELEMENTS[2986] = Fluid3D([15536,16069,15815,15517],0); -ELEMENTS[2987] = Fluid3D([15536,16069,15517,15622],0); -ELEMENTS[2988] = Fluid3D([15536,16069,15622,16013],0); -ELEMENTS[2989] = Fluid3D([16102,15536,15815,15617],0); -ELEMENTS[2990] = Fluid3D([16315,16102,16013,16619],0); -ELEMENTS[2991] = Fluid3D([15712,16013,15536,15403],0); -ELEMENTS[2992] = Fluid3D([15712,16013,15403,15878],0); -ELEMENTS[2993] = Fluid3D([15403,15712,15878,15294],0); -ELEMENTS[2994] = Fluid3D([16013,15536,15403,15622],0); -ELEMENTS[2995] = Fluid3D([15403,15712,15294,15015],0); -ELEMENTS[2996] = Fluid3D([15712,15294,15015,15306],0); -ELEMENTS[2997] = Fluid3D([15403,15712,15015,15536],0); -ELEMENTS[2998] = Fluid3D([15712,15294,15306,15974],0); -ELEMENTS[2999] = Fluid3D([15712,16013,15878,16315],0); -ELEMENTS[3000] = Fluid3D([16485,16086,15931,16139],0); -ELEMENTS[3001] = Fluid3D([16485,16086,16139,16542],0); -ELEMENTS[3002] = Fluid3D([15931,16485,16139,16188],0); -ELEMENTS[3003] = Fluid3D([15931,16485,16188,16355],0); -ELEMENTS[3004] = Fluid3D([16485,16139,16188,16595],0); -ELEMENTS[3005] = Fluid3D([16139,16188,16595,16087],0); -ELEMENTS[3006] = Fluid3D([16188,16595,16087,16638],0); -ELEMENTS[3007] = Fluid3D([16188,16595,16638,16805],0); -ELEMENTS[3008] = Fluid3D([16188,16595,16805,16485],0); -ELEMENTS[3009] = Fluid3D([16595,16638,16805,17224],0); -ELEMENTS[3010] = Fluid3D([16638,16188,16805,16475],0); -ELEMENTS[3011] = Fluid3D([16638,16188,16475,16174],0); -ELEMENTS[3012] = Fluid3D([16595,16087,16638,16331],0); -ELEMENTS[3013] = Fluid3D([16087,16638,16331,15884],0); -ELEMENTS[3014] = Fluid3D([16331,16087,15884,15679],0); -ELEMENTS[3015] = Fluid3D([16331,16087,15679,16101],0); -ELEMENTS[3016] = Fluid3D([16331,16087,16101,16348],0); -ELEMENTS[3017] = Fluid3D([16087,16188,16638,15884],0); -ELEMENTS[3018] = Fluid3D([15679,16331,16101,15814],0); -ELEMENTS[3019] = Fluid3D([16087,15679,16101,15678],0); -ELEMENTS[3020] = Fluid3D([15884,16331,15679,16003],0); -ELEMENTS[3021] = Fluid3D([16087,15884,15679,15648],0); -ELEMENTS[3022] = Fluid3D([15679,16331,15814,16003],0); -ELEMENTS[3023] = Fluid3D([16331,16101,15814,16590],0); -ELEMENTS[3024] = Fluid3D([16101,16087,15678,16348],0); -ELEMENTS[3025] = Fluid3D([16188,16805,16475,16355],0); -ELEMENTS[3026] = Fluid3D([16188,16638,15884,16174],0); -ELEMENTS[3027] = Fluid3D([16638,15884,16174,16331],0); -ELEMENTS[3028] = Fluid3D([15884,16174,16331,16003],0); -ELEMENTS[3029] = Fluid3D([16087,15679,15678,15648],0); -ELEMENTS[3030] = Fluid3D([16805,16638,16475,17045],0); -ELEMENTS[3031] = Fluid3D([16087,15884,15648,16188],0); -ELEMENTS[3032] = Fluid3D([15678,16087,15648,16139],0); -ELEMENTS[3033] = Fluid3D([16139,16188,16087,15648],0); -ELEMENTS[3034] = Fluid3D([15679,15678,15648,15092],0); -ELEMENTS[3035] = Fluid3D([15679,16101,15678,15429],0); -ELEMENTS[3036] = Fluid3D([15648,15679,15092,15336],0); -ELEMENTS[3037] = Fluid3D([16101,15678,15429,15786],0); -ELEMENTS[3038] = Fluid3D([15679,15678,15092,15429],0); -ELEMENTS[3039] = Fluid3D([15679,15092,15336,15082],0); -ELEMENTS[3040] = Fluid3D([15679,15092,15082,15429],0); -ELEMENTS[3041] = Fluid3D([15648,15679,15336,15884],0); -ELEMENTS[3042] = Fluid3D([16101,15678,15786,16348],0); -ELEMENTS[3043] = Fluid3D([15678,15429,15786,15108],0); -ELEMENTS[3044] = Fluid3D([15678,15429,15108,15092],0); -ELEMENTS[3045] = Fluid3D([15786,15678,15108,15667],0); -ELEMENTS[3046] = Fluid3D([15786,15678,15667,16348],0); -ELEMENTS[3047] = Fluid3D([16101,15679,15814,15429],0); -ELEMENTS[3048] = Fluid3D([15092,15648,15336,15007],0); -ELEMENTS[3049] = Fluid3D([15678,15648,15092,15360],0); -ELEMENTS[3050] = Fluid3D([15336,15679,15082,15511],0); -ELEMENTS[3051] = Fluid3D([15336,15679,15511,15884],0); -ELEMENTS[3052] = Fluid3D([15092,15648,15007,15360],0); -ELEMENTS[3053] = Fluid3D([15092,15336,15082,14565],0); -ELEMENTS[3054] = Fluid3D([15336,15082,14565,14950],0); -ELEMENTS[3055] = Fluid3D([15336,15082,14950,15511],0); -ELEMENTS[3056] = Fluid3D([16086,15931,16139,15360],0); -ELEMENTS[3057] = Fluid3D([15429,16101,15786,15849],0); -ELEMENTS[3058] = Fluid3D([16101,15786,15849,16323],0); -ELEMENTS[3059] = Fluid3D([16101,15786,16323,16348],0); -ELEMENTS[3060] = Fluid3D([15849,16101,16323,16590],0); -ELEMENTS[3061] = Fluid3D([16101,16323,16590,16712],0); -ELEMENTS[3062] = Fluid3D([16101,16323,16712,16348],0); -ELEMENTS[3063] = Fluid3D([15429,16101,15849,15814],0); -ELEMENTS[3064] = Fluid3D([16595,16139,16087,16348],0); -ELEMENTS[3065] = Fluid3D([16595,16139,16348,16542],0); -ELEMENTS[3066] = Fluid3D([16139,16087,16348,15678],0); -ELEMENTS[3067] = Fluid3D([16087,16595,16348,16331],0); -ELEMENTS[3068] = Fluid3D([15429,15786,15108,15240],0); -ELEMENTS[3069] = Fluid3D([15108,15429,15240,14721],0); -ELEMENTS[3070] = Fluid3D([15429,15240,14721,15137],0); -ELEMENTS[3071] = Fluid3D([15429,15786,15240,15849],0); -ELEMENTS[3072] = Fluid3D([15429,15240,15137,15849],0); -ELEMENTS[3073] = Fluid3D([15108,15429,14721,15092],0); -ELEMENTS[3074] = Fluid3D([15786,15108,15240,15391],0); -ELEMENTS[3075] = Fluid3D([15786,15108,15391,15667],0); -ELEMENTS[3076] = Fluid3D([15108,15240,15391,14685],0); -ELEMENTS[3077] = Fluid3D([15108,15240,14685,14721],0); -ELEMENTS[3078] = Fluid3D([15240,15391,14685,15144],0); -ELEMENTS[3079] = Fluid3D([15240,15391,15144,15726],0); -ELEMENTS[3080] = Fluid3D([15391,14685,15144,14880],0); -ELEMENTS[3081] = Fluid3D([15391,14685,14880,14882],0); -ELEMENTS[3082] = Fluid3D([15391,14685,14882,15108],0); -ELEMENTS[3083] = Fluid3D([15391,15144,15726,15526],0); -ELEMENTS[3084] = Fluid3D([15726,15391,15526,15999],0); -ELEMENTS[3085] = Fluid3D([15726,15391,15999,15786],0); -ELEMENTS[3086] = Fluid3D([15391,15144,15526,14880],0); -ELEMENTS[3087] = Fluid3D([15240,15786,15391,15726],0); -ELEMENTS[3088] = Fluid3D([15240,14721,15137,14599],0); -ELEMENTS[3089] = Fluid3D([14721,15137,14599,14463],0); -ELEMENTS[3090] = Fluid3D([15137,15240,14599,15268],0); -ELEMENTS[3091] = Fluid3D([15137,14599,14463,14706],0); -ELEMENTS[3092] = Fluid3D([15137,14599,14706,15268],0); -ELEMENTS[3093] = Fluid3D([15240,14721,14599,14685],0); -ELEMENTS[3094] = Fluid3D([14721,15137,14463,15082],0); -ELEMENTS[3095] = Fluid3D([15137,15240,15268,15849],0); -ELEMENTS[3096] = Fluid3D([14599,14721,14463,13944],0); -ELEMENTS[3097] = Fluid3D([14721,14463,13944,14171],0); -ELEMENTS[3098] = Fluid3D([14599,14721,13944,14685],0); -ELEMENTS[3099] = Fluid3D([14463,13944,14171,13522],0); -ELEMENTS[3100] = Fluid3D([14463,14599,13944,13872],0); -ELEMENTS[3101] = Fluid3D([14463,14599,13872,14706],0); -ELEMENTS[3102] = Fluid3D([13944,14171,13522,13310],0); -ELEMENTS[3103] = Fluid3D([13522,13944,13310,13075],0); -ELEMENTS[3104] = Fluid3D([13522,13944,13075,13872],0); -ELEMENTS[3105] = Fluid3D([13944,14171,13310,14226],0); -ELEMENTS[3106] = Fluid3D([14171,13310,14226,13768],0); -ELEMENTS[3107] = Fluid3D([14171,13310,13768,13434],0); -ELEMENTS[3108] = Fluid3D([14171,13310,13434,13522],0); -ELEMENTS[3109] = Fluid3D([13944,14171,14226,14721],0); -ELEMENTS[3110] = Fluid3D([14721,14463,14171,15082],0); -ELEMENTS[3111] = Fluid3D([14171,14463,13522,14210],0); -ELEMENTS[3112] = Fluid3D([14171,14463,14210,15082],0); -ELEMENTS[3113] = Fluid3D([14463,13522,14210,13988],0); -ELEMENTS[3114] = Fluid3D([13522,14171,14210,13434],0); -ELEMENTS[3115] = Fluid3D([13522,14210,13988,13170],0); -ELEMENTS[3116] = Fluid3D([14210,13988,13170,14111],0); -ELEMENTS[3117] = Fluid3D([14210,13988,14111,14648],0); -ELEMENTS[3118] = Fluid3D([14210,13988,14648,14463],0); -ELEMENTS[3119] = Fluid3D([13522,14210,13170,13434],0); -ELEMENTS[3120] = Fluid3D([14463,13944,13522,13872],0); -ELEMENTS[3121] = Fluid3D([14463,13522,13988,13872],0); -ELEMENTS[3122] = Fluid3D([13988,13522,13170,13024],0); -ELEMENTS[3123] = Fluid3D([13988,13522,13024,13872],0); -ELEMENTS[3124] = Fluid3D([13522,13170,13024,12578],0); -ELEMENTS[3125] = Fluid3D([13024,13522,12578,13075],0); -ELEMENTS[3126] = Fluid3D([13522,13170,12578,13434],0); -ELEMENTS[3127] = Fluid3D([13170,13988,13024,13270],0); -ELEMENTS[3128] = Fluid3D([13170,13988,13270,14111],0); -ELEMENTS[3129] = Fluid3D([13988,13024,13270,13560],0); -ELEMENTS[3130] = Fluid3D([13024,13270,13560,12661],0); -ELEMENTS[3131] = Fluid3D([13024,13170,13270,12427],0); -ELEMENTS[3132] = Fluid3D([13024,13270,12661,12427],0); -ELEMENTS[3133] = Fluid3D([13024,13170,12427,12578],0); -ELEMENTS[3134] = Fluid3D([13988,13024,13560,13872],0); -ELEMENTS[3135] = Fluid3D([13270,13560,12661,13305],0); -ELEMENTS[3136] = Fluid3D([13560,12661,13305,13092],0); -ELEMENTS[3137] = Fluid3D([13270,13560,13305,14068],0); -ELEMENTS[3138] = Fluid3D([13270,13560,14068,13988],0); -ELEMENTS[3139] = Fluid3D([12661,13305,13092,12479],0); -ELEMENTS[3140] = Fluid3D([13092,12661,12479,12159],0); -ELEMENTS[3141] = Fluid3D([13092,12661,12159,12813],0); -ELEMENTS[3142] = Fluid3D([13092,12661,12813,13560],0); -ELEMENTS[3143] = Fluid3D([12661,13305,12479,12419],0); -ELEMENTS[3144] = Fluid3D([12661,13305,12419,13270],0); -ELEMENTS[3145] = Fluid3D([13305,12479,12419,12923],0); -ELEMENTS[3146] = Fluid3D([13305,12479,12923,13274],0); -ELEMENTS[3147] = Fluid3D([13305,12479,13274,13092],0); -ELEMENTS[3148] = Fluid3D([12479,12419,12923,11954],0); -ELEMENTS[3149] = Fluid3D([12479,12419,11954,11716],0); -ELEMENTS[3150] = Fluid3D([12479,12419,11716,12661],0); -ELEMENTS[3151] = Fluid3D([12923,12479,11954,12377],0); -ELEMENTS[3152] = Fluid3D([12923,12479,12377,13274],0); -ELEMENTS[3153] = Fluid3D([12479,11954,12377,11594],0); -ELEMENTS[3154] = Fluid3D([12479,11954,11594,11716],0); -ELEMENTS[3155] = Fluid3D([12377,12479,11594,12212],0); -ELEMENTS[3156] = Fluid3D([12377,12479,12212,13274],0); -ELEMENTS[3157] = Fluid3D([12479,11594,12212,12159],0); -ELEMENTS[3158] = Fluid3D([13305,13560,13092,13951],0); -ELEMENTS[3159] = Fluid3D([13305,13560,13951,14068],0); -ELEMENTS[3160] = Fluid3D([13560,13092,13951,13779],0); -ELEMENTS[3161] = Fluid3D([13560,13092,13779,12813],0); -ELEMENTS[3162] = Fluid3D([13092,13305,13951,13274],0); -ELEMENTS[3163] = Fluid3D([13951,13560,13779,14377],0); -ELEMENTS[3164] = Fluid3D([13951,13560,14377,14068],0); -ELEMENTS[3165] = Fluid3D([13560,13779,14377,13872],0); -ELEMENTS[3166] = Fluid3D([13779,13951,14377,14493],0); -ELEMENTS[3167] = Fluid3D([13951,14377,14493,14796],0); -ELEMENTS[3168] = Fluid3D([13951,14377,14796,14068],0); -ELEMENTS[3169] = Fluid3D([13779,13951,14493,13765],0); -ELEMENTS[3170] = Fluid3D([13951,14493,13765,14216],0); -ELEMENTS[3171] = Fluid3D([13951,14493,14216,14796],0); -ELEMENTS[3172] = Fluid3D([13779,13951,13765,13092],0); -ELEMENTS[3173] = Fluid3D([12419,13305,12923,13358],0); -ELEMENTS[3174] = Fluid3D([12419,13305,13358,13270],0); -ELEMENTS[3175] = Fluid3D([13305,12923,13358,13829],0); -ELEMENTS[3176] = Fluid3D([13305,12923,13829,13274],0); -ELEMENTS[3177] = Fluid3D([12923,13358,13829,13453],0); -ELEMENTS[3178] = Fluid3D([13829,12923,13453,13369],0); -ELEMENTS[3179] = Fluid3D([13829,12923,13369,13274],0); -ELEMENTS[3180] = Fluid3D([12923,13358,13453,12640],0); -ELEMENTS[3181] = Fluid3D([12923,13358,12640,12419],0); -ELEMENTS[3182] = Fluid3D([13358,13453,12640,13394],0); -ELEMENTS[3183] = Fluid3D([13453,12640,13394,12956],0); -ELEMENTS[3184] = Fluid3D([13358,13453,13394,14118],0); -ELEMENTS[3185] = Fluid3D([13453,12640,12956,12646],0); -ELEMENTS[3186] = Fluid3D([13453,12640,12646,12923],0); -ELEMENTS[3187] = Fluid3D([13358,13453,14118,13829],0); -ELEMENTS[3188] = Fluid3D([13358,13305,13829,14068],0); -ELEMENTS[3189] = Fluid3D([14377,13779,14493,14478],0); -ELEMENTS[3190] = Fluid3D([14377,13779,14478,13872],0); -ELEMENTS[3191] = Fluid3D([14493,14377,14478,15083],0); -ELEMENTS[3192] = Fluid3D([14377,14478,15083,14706],0); -ELEMENTS[3193] = Fluid3D([13779,14493,14478,14152],0); -ELEMENTS[3194] = Fluid3D([14493,14478,14152,14956],0); -ELEMENTS[3195] = Fluid3D([14493,14478,14956,15083],0); -ELEMENTS[3196] = Fluid3D([13779,14493,14152,13765],0); -ELEMENTS[3197] = Fluid3D([14493,14377,15083,14796],0); -ELEMENTS[3198] = Fluid3D([11954,12923,12377,12646],0); -ELEMENTS[3199] = Fluid3D([14478,13779,14152,13778],0); -ELEMENTS[3200] = Fluid3D([14478,13779,13778,13872],0); -ELEMENTS[3201] = Fluid3D([13779,14152,13778,13271],0); -ELEMENTS[3202] = Fluid3D([13778,13779,13271,12813],0); -ELEMENTS[3203] = Fluid3D([13779,14152,13271,13765],0); -ELEMENTS[3204] = Fluid3D([14152,14478,13778,14492],0); -ELEMENTS[3205] = Fluid3D([14152,14478,14492,14956],0); -ELEMENTS[3206] = Fluid3D([14478,13778,14492,14375],0); -ELEMENTS[3207] = Fluid3D([14492,14478,14375,15081],0); -ELEMENTS[3208] = Fluid3D([14492,14478,15081,14956],0); -ELEMENTS[3209] = Fluid3D([13778,14152,14492,13792],0); -ELEMENTS[3210] = Fluid3D([14152,14492,13792,14510],0); -ELEMENTS[3211] = Fluid3D([14152,14492,14510,14956],0); -ELEMENTS[3212] = Fluid3D([13778,14152,13792,13271],0); -ELEMENTS[3213] = Fluid3D([14478,13778,14375,13872],0); -ELEMENTS[3214] = Fluid3D([14375,14492,15081,14842],0); -ELEMENTS[3215] = Fluid3D([14492,15081,14842,15219],0); -ELEMENTS[3216] = Fluid3D([14375,14492,14842,14018],0); -ELEMENTS[3217] = Fluid3D([15081,14842,15219,15563],0); -ELEMENTS[3218] = Fluid3D([15081,14842,15563,15144],0); -ELEMENTS[3219] = Fluid3D([14375,14492,14018,13778],0); -ELEMENTS[3220] = Fluid3D([14492,15081,15219,14956],0); -ELEMENTS[3221] = Fluid3D([15081,14375,14842,15144],0); -ELEMENTS[3222] = Fluid3D([14842,14492,15219,14640],0); -ELEMENTS[3223] = Fluid3D([14492,15219,14640,14510],0); -ELEMENTS[3224] = Fluid3D([14842,14492,14640,14018],0); -ELEMENTS[3225] = Fluid3D([15219,14842,14640,15281],0); -ELEMENTS[3226] = Fluid3D([15219,14842,15281,15563],0); -ELEMENTS[3227] = Fluid3D([14842,14640,15281,14615],0); -ELEMENTS[3228] = Fluid3D([14842,14640,14615,14018],0); -ELEMENTS[3229] = Fluid3D([15281,14842,14615,15138],0); -ELEMENTS[3230] = Fluid3D([15281,14842,15138,15563],0); -ELEMENTS[3231] = Fluid3D([14842,14615,15138,14393],0); -ELEMENTS[3232] = Fluid3D([14615,15138,14393,14812],0); -ELEMENTS[3233] = Fluid3D([14615,15138,14812,15020],0); -ELEMENTS[3234] = Fluid3D([14615,15138,15020,15281],0); -ELEMENTS[3235] = Fluid3D([14842,14615,14393,14018],0); -ELEMENTS[3236] = Fluid3D([14640,15281,14615,14832],0); -ELEMENTS[3237] = Fluid3D([14615,14640,14832,14075],0); -ELEMENTS[3238] = Fluid3D([14640,15281,14832,15238],0); -ELEMENTS[3239] = Fluid3D([15281,14615,14832,15020],0); -ELEMENTS[3240] = Fluid3D([14640,15281,15238,15219],0); -ELEMENTS[3241] = Fluid3D([14615,14640,14075,14018],0); -ELEMENTS[3242] = Fluid3D([14640,14832,14075,14455],0); -ELEMENTS[3243] = Fluid3D([14832,14075,14455,14313],0); -ELEMENTS[3244] = Fluid3D([14640,14832,14455,15238],0); -ELEMENTS[3245] = Fluid3D([14075,14455,14313,13657],0); -ELEMENTS[3246] = Fluid3D([14075,14455,13657,13825],0); -ELEMENTS[3247] = Fluid3D([14075,14455,13825,14640],0); -ELEMENTS[3248] = Fluid3D([14455,14313,13657,14238],0); -ELEMENTS[3249] = Fluid3D([14455,14313,14238,14952],0); -ELEMENTS[3250] = Fluid3D([14455,14313,14952,14832],0); -ELEMENTS[3251] = Fluid3D([14313,13657,14238,13680],0); -ELEMENTS[3252] = Fluid3D([13657,14238,13680,13389],0); -ELEMENTS[3253] = Fluid3D([14313,13657,13680,13633],0); -ELEMENTS[3254] = Fluid3D([14313,13657,13633,14075],0); -ELEMENTS[3255] = Fluid3D([13657,14238,13389,13860],0); -ELEMENTS[3256] = Fluid3D([13657,14238,13860,14455],0); -ELEMENTS[3257] = Fluid3D([14238,13389,13860,14109],0); -ELEMENTS[3258] = Fluid3D([14238,13389,14109,13914],0); -ELEMENTS[3259] = Fluid3D([14238,13389,13914,13680],0); -ELEMENTS[3260] = Fluid3D([13389,13860,14109,13222],0); -ELEMENTS[3261] = Fluid3D([13389,13860,13222,12981],0); -ELEMENTS[3262] = Fluid3D([13389,13860,12981,13657],0); -ELEMENTS[3263] = Fluid3D([14109,13389,13222,13474],0); -ELEMENTS[3264] = Fluid3D([13389,13222,13474,12531],0); -ELEMENTS[3265] = Fluid3D([13389,13222,12531,12981],0); -ELEMENTS[3266] = Fluid3D([14109,13389,13474,13914],0); -ELEMENTS[3267] = Fluid3D([14238,14313,13680,14485],0); -ELEMENTS[3268] = Fluid3D([13680,14238,14485,13914],0); -ELEMENTS[3269] = Fluid3D([14238,14313,14485,14952],0); -ELEMENTS[3270] = Fluid3D([14313,13680,14485,14169],0); -ELEMENTS[3271] = Fluid3D([13680,14485,14169,13886],0); -ELEMENTS[3272] = Fluid3D([13680,14485,13886,13914],0); -ELEMENTS[3273] = Fluid3D([14313,13680,14169,13633],0); -ELEMENTS[3274] = Fluid3D([14485,14169,13886,14691],0); -ELEMENTS[3275] = Fluid3D([14169,13886,14691,13941],0); -ELEMENTS[3276] = Fluid3D([14485,14169,14691,14877],0); -ELEMENTS[3277] = Fluid3D([14485,14169,14877,14313],0); -ELEMENTS[3278] = Fluid3D([13886,14485,14691,14575],0); -ELEMENTS[3279] = Fluid3D([14691,13886,14575,14257],0); -ELEMENTS[3280] = Fluid3D([14691,13886,14257,13941],0); -ELEMENTS[3281] = Fluid3D([13886,14485,14575,13914],0); -ELEMENTS[3282] = Fluid3D([14169,13886,13941,13308],0); -ELEMENTS[3283] = Fluid3D([14169,13886,13308,13680],0); -ELEMENTS[3284] = Fluid3D([13886,13941,13308,13291],0); -ELEMENTS[3285] = Fluid3D([13886,13941,13291,14257],0); -ELEMENTS[3286] = Fluid3D([13941,13308,13291,13109],0); -ELEMENTS[3287] = Fluid3D([13308,13291,13109,12472],0); -ELEMENTS[3288] = Fluid3D([13941,13308,13109,13652],0); -ELEMENTS[3289] = Fluid3D([13941,13308,13652,14169],0); -ELEMENTS[3290] = Fluid3D([13308,13291,12472,12935],0); -ELEMENTS[3291] = Fluid3D([13308,13291,12935,13886],0); -ELEMENTS[3292] = Fluid3D([12472,13308,12935,12500],0); -ELEMENTS[3293] = Fluid3D([12935,12472,12500,11908],0); -ELEMENTS[3294] = Fluid3D([12935,12472,11908,12421],0); -ELEMENTS[3295] = Fluid3D([12935,12472,12421,13291],0); -ELEMENTS[3296] = Fluid3D([12472,13308,12500,12673],0); -ELEMENTS[3297] = Fluid3D([13308,12500,12673,13633],0); -ELEMENTS[3298] = Fluid3D([12472,13308,12673,13109],0); -ELEMENTS[3299] = Fluid3D([13291,13941,13109,13631],0); -ELEMENTS[3300] = Fluid3D([13291,13941,13631,14257],0); -ELEMENTS[3301] = Fluid3D([13941,13109,13631,13848],0); -ELEMENTS[3302] = Fluid3D([13109,13631,13848,13113],0); -ELEMENTS[3303] = Fluid3D([13109,13631,13113,12711],0); -ELEMENTS[3304] = Fluid3D([13941,13109,13848,13652],0); -ELEMENTS[3305] = Fluid3D([13109,13631,12711,13291],0); -ELEMENTS[3306] = Fluid3D([13631,13941,13848,14447],0); -ELEMENTS[3307] = Fluid3D([13631,13941,14447,14257],0); -ELEMENTS[3308] = Fluid3D([13848,13631,14447,14029],0); -ELEMENTS[3309] = Fluid3D([13848,13631,14029,13113],0); -ELEMENTS[3310] = Fluid3D([13941,13848,14447,14505],0); -ELEMENTS[3311] = Fluid3D([13941,13848,14505,13652],0); -ELEMENTS[3312] = Fluid3D([13848,14447,14505,14610],0); -ELEMENTS[3313] = Fluid3D([14447,14505,14610,15143],0); -ELEMENTS[3314] = Fluid3D([14447,14505,15143,14691],0); -ELEMENTS[3315] = Fluid3D([13848,14447,14610,14029],0); -ELEMENTS[3316] = Fluid3D([13631,14447,14029,14246],0); -ELEMENTS[3317] = Fluid3D([14447,14029,14246,14821],0); -ELEMENTS[3318] = Fluid3D([14447,14029,14821,14610],0); -ELEMENTS[3319] = Fluid3D([13631,14447,14246,14257],0); -ELEMENTS[3320] = Fluid3D([14029,14246,14821,14299],0); -ELEMENTS[3321] = Fluid3D([14821,14029,14299,14535],0); -ELEMENTS[3322] = Fluid3D([14246,14821,14299,14872],0); -ELEMENTS[3323] = Fluid3D([14246,14821,14872,15076],0); -ELEMENTS[3324] = Fluid3D([14246,14821,15076,14447],0); -ELEMENTS[3325] = Fluid3D([14029,14246,14299,13528],0); -ELEMENTS[3326] = Fluid3D([14246,14299,13528,14023],0); -ELEMENTS[3327] = Fluid3D([14246,14299,14023,14872],0); -ELEMENTS[3328] = Fluid3D([14029,14246,13528,13631],0); -ELEMENTS[3329] = Fluid3D([14821,14029,14535,14610],0); -ELEMENTS[3330] = Fluid3D([14832,14075,14313,14491],0); -ELEMENTS[3331] = Fluid3D([14832,14075,14491,14615],0); -ELEMENTS[3332] = Fluid3D([14313,14832,14491,14877],0); -ELEMENTS[3333] = Fluid3D([14075,14313,14491,13633],0); -ELEMENTS[3334] = Fluid3D([13860,14238,14109,14655],0); -ELEMENTS[3335] = Fluid3D([13860,14238,14655,14455],0); -ELEMENTS[3336] = Fluid3D([14238,14109,14655,14860],0); -ELEMENTS[3337] = Fluid3D([14655,14238,14860,14952],0); -ELEMENTS[3338] = Fluid3D([14238,14109,14860,13914],0); -ELEMENTS[3339] = Fluid3D([14109,14655,14860,14708],0); -ELEMENTS[3340] = Fluid3D([14655,14860,14708,15352],0); -ELEMENTS[3341] = Fluid3D([14860,14109,14708,14320],0); -ELEMENTS[3342] = Fluid3D([14109,14655,14708,14201],0); -ELEMENTS[3343] = Fluid3D([14109,14655,14201,13860],0); -ELEMENTS[3344] = Fluid3D([14860,14109,14320,13914],0); -ELEMENTS[3345] = Fluid3D([14655,14860,15352,14952],0); -ELEMENTS[3346] = Fluid3D([14708,14860,14320,15107],0); -ELEMENTS[3347] = Fluid3D([14708,14860,15107,15352],0); -ELEMENTS[3348] = Fluid3D([14860,14320,15107,14784],0); -ELEMENTS[3349] = Fluid3D([15107,14860,14784,15363],0); -ELEMENTS[3350] = Fluid3D([15107,14860,15363,15352],0); -ELEMENTS[3351] = Fluid3D([14860,14320,14784,13914],0); -ELEMENTS[3352] = Fluid3D([14320,14708,15107,14740],0); -ELEMENTS[3353] = Fluid3D([14708,15107,14740,15322],0); -ELEMENTS[3354] = Fluid3D([15107,14320,14740,14785],0); -ELEMENTS[3355] = Fluid3D([15107,14320,14785,14784],0); -ELEMENTS[3356] = Fluid3D([14320,14708,14740,13895],0); -ELEMENTS[3357] = Fluid3D([14708,14740,13895,14702],0); -ELEMENTS[3358] = Fluid3D([14708,14740,14702,15322],0); -ELEMENTS[3359] = Fluid3D([14320,14708,13895,14109],0); -ELEMENTS[3360] = Fluid3D([14708,15107,15322,15352],0); -ELEMENTS[3361] = Fluid3D([14740,14320,13895,14008],0); -ELEMENTS[3362] = Fluid3D([14740,14320,14008,14785],0); -ELEMENTS[3363] = Fluid3D([13895,14740,14008,14204],0); -ELEMENTS[3364] = Fluid3D([14740,14008,14204,14627],0); -ELEMENTS[3365] = Fluid3D([14740,14008,14627,14785],0); -ELEMENTS[3366] = Fluid3D([14320,13895,14008,13474],0); -ELEMENTS[3367] = Fluid3D([13895,14740,14204,14702],0); -ELEMENTS[3368] = Fluid3D([14860,14784,15363,14822],0); -ELEMENTS[3369] = Fluid3D([14784,15363,14822,15258],0); -ELEMENTS[3370] = Fluid3D([15363,14822,15258,15502],0); -ELEMENTS[3371] = Fluid3D([15363,14822,15502,14952],0); -ELEMENTS[3372] = Fluid3D([14860,14784,14822,13914],0); -ELEMENTS[3373] = Fluid3D([15363,14860,14822,14952],0); -ELEMENTS[3374] = Fluid3D([14822,15258,15502,14575],0); -ELEMENTS[3375] = Fluid3D([14822,15258,14575,14784],0); -ELEMENTS[3376] = Fluid3D([14575,14822,14784,13914],0); -ELEMENTS[3377] = Fluid3D([14784,15363,15258,15439],0); -ELEMENTS[3378] = Fluid3D([15363,15258,15439,15873],0); -ELEMENTS[3379] = Fluid3D([14784,15363,15439,15107],0); -ELEMENTS[3380] = Fluid3D([15258,15439,15873,15700],0); -ELEMENTS[3381] = Fluid3D([15258,15439,15700,14946],0); -ELEMENTS[3382] = Fluid3D([15258,15439,14946,14784],0); -ELEMENTS[3383] = Fluid3D([15873,15258,15700,15790],0); -ELEMENTS[3384] = Fluid3D([15258,15700,15790,15231],0); -ELEMENTS[3385] = Fluid3D([15258,15700,15231,14946],0); -ELEMENTS[3386] = Fluid3D([15873,15258,15790,15502],0); -ELEMENTS[3387] = Fluid3D([15700,15873,15790,16398],0); -ELEMENTS[3388] = Fluid3D([15363,15258,15873,15502],0); -ELEMENTS[3389] = Fluid3D([15439,15363,15873,15860],0); -ELEMENTS[3390] = Fluid3D([15439,15363,15860,15107],0); -ELEMENTS[3391] = Fluid3D([15363,15873,15860,16017],0); -ELEMENTS[3392] = Fluid3D([15860,15363,16017,15352],0); -ELEMENTS[3393] = Fluid3D([15363,15873,16017,15502],0); -ELEMENTS[3394] = Fluid3D([15873,15860,16017,16480],0); -ELEMENTS[3395] = Fluid3D([15873,15439,15860,16127],0); -ELEMENTS[3396] = Fluid3D([12419,12923,11954,12640],0); -ELEMENTS[3397] = Fluid3D([16139,15931,16188,15648],0); -ELEMENTS[3398] = Fluid3D([16866,17017,16971,17338],0); -ELEMENTS[3399] = Fluid3D([14691,14485,14877,15502],0); -ELEMENTS[3400] = Fluid3D([16846,17141,17154,16619],0); -ELEMENTS[3401] = Fluid3D([17275,16971,17035,17350],0); -ELEMENTS[3402] = Fluid3D([17275,16971,17350,17338],0); -ELEMENTS[3403] = Fluid3D([16971,17035,17350,16848],0); -ELEMENTS[3404] = Fluid3D([17035,17275,17350,17464],0); -ELEMENTS[3405] = Fluid3D([17275,17350,17464,17656],0); -ELEMENTS[3406] = Fluid3D([17350,17464,17656,17693],0); -ELEMENTS[3407] = Fluid3D([17350,17464,17693,17387],0); -ELEMENTS[3408] = Fluid3D([17035,17275,17464,17154],0); -ELEMENTS[3409] = Fluid3D([17464,17656,17693,17840],0); -ELEMENTS[3410] = Fluid3D([17656,17693,17840,17960],0); -ELEMENTS[3411] = Fluid3D([17656,17693,17960,17749],0); -ELEMENTS[3412] = Fluid3D([17656,17693,17749,17350],0); -ELEMENTS[3413] = Fluid3D([17464,17693,17387,17659],0); -ELEMENTS[3414] = Fluid3D([17464,17693,17659,17840],0); -ELEMENTS[3415] = Fluid3D([17693,17387,17659,17624],0); -ELEMENTS[3416] = Fluid3D([17387,17659,17624,17428],0); -ELEMENTS[3417] = Fluid3D([17693,17387,17624,17618],0); -ELEMENTS[3418] = Fluid3D([17624,17693,17618,18011],0); -ELEMENTS[3419] = Fluid3D([17618,17624,18011,17876],0); -ELEMENTS[3420] = Fluid3D([17618,17624,17876,17543],0); -ELEMENTS[3421] = Fluid3D([17387,17659,17428,17271],0); -ELEMENTS[3422] = Fluid3D([17428,17387,17271,16805],0); -ELEMENTS[3423] = Fluid3D([17387,17659,17271,17464],0); -ELEMENTS[3424] = Fluid3D([17350,17464,17387,17035],0); -ELEMENTS[3425] = Fluid3D([17464,17656,17840,17626],0); -ELEMENTS[3426] = Fluid3D([17656,17840,17626,17924],0); -ELEMENTS[3427] = Fluid3D([17464,17656,17626,17275],0); -ELEMENTS[3428] = Fluid3D([17840,17464,17626,17646],0); -ELEMENTS[3429] = Fluid3D([17626,17840,17646,17879],0); -ELEMENTS[3430] = Fluid3D([17840,17464,17646,17659],0); -ELEMENTS[3431] = Fluid3D([17626,17840,17879,17924],0); -ELEMENTS[3432] = Fluid3D([17626,17656,17924,17536],0); -ELEMENTS[3433] = Fluid3D([17656,17840,17924,17960],0); -ELEMENTS[3434] = Fluid3D([17659,17693,17624,17948],0); -ELEMENTS[3435] = Fluid3D([17659,17693,17948,17840],0); -ELEMENTS[3436] = Fluid3D([17693,17624,17948,18011],0); -ELEMENTS[3437] = Fluid3D([17624,17659,17948,17841],0); -ELEMENTS[3438] = Fluid3D([17659,17948,17841,17901],0); -ELEMENTS[3439] = Fluid3D([17624,17659,17841,17428],0); -ELEMENTS[3440] = Fluid3D([17948,17841,17901,18143],0); -ELEMENTS[3441] = Fluid3D([17948,17841,18143,17876],0); -ELEMENTS[3442] = Fluid3D([17841,17901,18143,18014],0); -ELEMENTS[3443] = Fluid3D([17841,17901,18014,17798],0); -ELEMENTS[3444] = Fluid3D([17901,18143,18014,18243],0); -ELEMENTS[3445] = Fluid3D([17841,17901,17798,17659],0); -ELEMENTS[3446] = Fluid3D([17901,18143,18243,18178],0); -ELEMENTS[3447] = Fluid3D([18143,18243,18178,18347],0); -ELEMENTS[3448] = Fluid3D([18143,18243,18347,18282],0); -ELEMENTS[3449] = Fluid3D([18143,18243,18282,18014],0); -ELEMENTS[3450] = Fluid3D([17901,18143,18178,17948],0); -ELEMENTS[3451] = Fluid3D([17659,17948,17901,17840],0); -ELEMENTS[3452] = Fluid3D([17948,17624,17841,17876],0); -ELEMENTS[3453] = Fluid3D([18243,17901,18178,18127],0); -ELEMENTS[3454] = Fluid3D([18243,17901,18127,18009],0); -ELEMENTS[3455] = Fluid3D([17901,18127,18009,17812],0); -ELEMENTS[3456] = Fluid3D([17901,18127,17812,17840],0); -ELEMENTS[3457] = Fluid3D([17901,18178,18127,17840],0); -ELEMENTS[3458] = Fluid3D([18127,18243,18009,18246],0); -ELEMENTS[3459] = Fluid3D([18009,18127,18246,18035],0); -ELEMENTS[3460] = Fluid3D([18243,18009,18246,18191],0); -ELEMENTS[3461] = Fluid3D([18243,18009,18191,18014],0); -ELEMENTS[3462] = Fluid3D([18127,18243,18246,18428],0); -ELEMENTS[3463] = Fluid3D([18009,18127,18035,17812],0); -ELEMENTS[3464] = Fluid3D([18243,17901,18009,18014],0); -ELEMENTS[3465] = Fluid3D([18178,18243,18127,18345],0); -ELEMENTS[3466] = Fluid3D([18243,18127,18345,18428],0); -ELEMENTS[3467] = Fluid3D([18178,18243,18345,18347],0); -ELEMENTS[3468] = Fluid3D([18127,18178,18345,18231],0); -ELEMENTS[3469] = Fluid3D([18127,18178,18231,17840],0); -ELEMENTS[3470] = Fluid3D([18178,18345,18231,18374],0); -ELEMENTS[3471] = Fluid3D([18231,18178,18374,18219],0); -ELEMENTS[3472] = Fluid3D([18178,18345,18374,18347],0); -ELEMENTS[3473] = Fluid3D([18231,18178,18219,17840],0); -ELEMENTS[3474] = Fluid3D([18374,18231,18219,18350],0); -ELEMENTS[3475] = Fluid3D([18374,18231,18350,18469],0); -ELEMENTS[3476] = Fluid3D([18219,18374,18350,18378],0); -ELEMENTS[3477] = Fluid3D([18219,18374,18378,18297],0); -ELEMENTS[3478] = Fluid3D([18219,18374,18297,18178],0); -ELEMENTS[3479] = Fluid3D([18231,18219,18350,18160],0); -ELEMENTS[3480] = Fluid3D([18219,18350,18160,18239],0); -ELEMENTS[3481] = Fluid3D([18219,18350,18239,18378],0); -ELEMENTS[3482] = Fluid3D([18231,18219,18160,17840],0); -ELEMENTS[3483] = Fluid3D([18374,18350,18378,18562],0); -ELEMENTS[3484] = Fluid3D([18345,18127,18231,18382],0); -ELEMENTS[3485] = Fluid3D([18345,18231,18374,18382],0); -ELEMENTS[3486] = Fluid3D([17275,17350,17656,17338],0); -ELEMENTS[3487] = Fluid3D([17464,17626,17646,17154],0); -ELEMENTS[3488] = Fluid3D([17693,17350,17387,17467],0); -ELEMENTS[3489] = Fluid3D([17693,17350,17467,17749],0); -ELEMENTS[3490] = Fluid3D([17387,17693,17467,17618],0); -ELEMENTS[3491] = Fluid3D([17693,17467,17618,17780],0); -ELEMENTS[3492] = Fluid3D([17467,17618,17780,17753],0); -ELEMENTS[3493] = Fluid3D([17618,17780,17753,18011],0); -ELEMENTS[3494] = Fluid3D([17780,17753,18011,18020],0); -ELEMENTS[3495] = Fluid3D([17780,17753,18020,17738],0); -ELEMENTS[3496] = Fluid3D([17780,17753,17738,17467],0); -ELEMENTS[3497] = Fluid3D([18011,17780,18020,18045],0); -ELEMENTS[3498] = Fluid3D([18011,17780,18045,17693],0); -ELEMENTS[3499] = Fluid3D([18020,17780,17738,17749],0); -ELEMENTS[3500] = Fluid3D([17780,17738,17749,17467],0); -ELEMENTS[3501] = Fluid3D([17749,17780,17467,17693],0); -ELEMENTS[3502] = Fluid3D([17749,17780,17693,18045],0); -ELEMENTS[3503] = Fluid3D([17780,18020,18045,17749],0); -ELEMENTS[3504] = Fluid3D([17467,17618,17753,17481],0); -ELEMENTS[3505] = Fluid3D([17618,17780,18011,17693],0); -ELEMENTS[3506] = Fluid3D([17753,18020,17738,17890],0); -ELEMENTS[3507] = Fluid3D([17738,17753,17890,17568],0); -ELEMENTS[3508] = Fluid3D([17890,17738,17568,17823],0); -ELEMENTS[3509] = Fluid3D([17738,17568,17823,17528],0); -ELEMENTS[3510] = Fluid3D([17738,17568,17528,17381],0); -ELEMENTS[3511] = Fluid3D([17738,17568,17381,17753],0); -ELEMENTS[3512] = Fluid3D([17568,17528,17381,17097],0); -ELEMENTS[3513] = Fluid3D([17568,17823,17528,17501],0); -ELEMENTS[3514] = Fluid3D([17528,17738,17381,17578],0); -ELEMENTS[3515] = Fluid3D([17823,17738,17528,17856],0); -ELEMENTS[3516] = Fluid3D([17528,17568,17501,17097],0); -ELEMENTS[3517] = Fluid3D([17738,17381,17578,17749],0); -ELEMENTS[3518] = Fluid3D([17578,17738,17749,17856],0); -ELEMENTS[3519] = Fluid3D([17568,17823,17501,17777],0); -ELEMENTS[3520] = Fluid3D([17823,17501,17777,17818],0); -ELEMENTS[3521] = Fluid3D([17777,17823,17818,18056],0); -ELEMENTS[3522] = Fluid3D([17777,17823,18056,17890],0); -ELEMENTS[3523] = Fluid3D([17568,17823,17777,17890],0); -ELEMENTS[3524] = Fluid3D([17501,17777,17818,17450],0); -ELEMENTS[3525] = Fluid3D([17818,17777,18056,17917],0); -ELEMENTS[3526] = Fluid3D([17818,17777,17917,17450],0); -ELEMENTS[3527] = Fluid3D([17823,17818,18056,18015],0); -ELEMENTS[3528] = Fluid3D([17501,17568,17777,17397],0); -ELEMENTS[3529] = Fluid3D([17777,17501,17397,17450],0); -ELEMENTS[3530] = Fluid3D([17501,17568,17397,17097],0); -ELEMENTS[3531] = Fluid3D([17777,18056,17917,17983],0); -ELEMENTS[3532] = Fluid3D([17777,18056,17983,17890],0); -ELEMENTS[3533] = Fluid3D([18056,17823,18015,18048],0); -ELEMENTS[3534] = Fluid3D([18056,17823,18048,17890],0); -ELEMENTS[3535] = Fluid3D([17528,17738,17578,17856],0); -ELEMENTS[3536] = Fluid3D([17823,17738,17856,18048],0); -ELEMENTS[3537] = Fluid3D([17777,17568,17890,17627],0); -ELEMENTS[3538] = Fluid3D([17823,17818,18015,17697],0); -ELEMENTS[3539] = Fluid3D([17753,18020,17890,18021],0); -ELEMENTS[3540] = Fluid3D([17823,17818,17697,17501],0); -ELEMENTS[3541] = Fluid3D([17753,18020,18021,18011],0); -ELEMENTS[3542] = Fluid3D([17501,17397,17450,17068],0); -ELEMENTS[3543] = Fluid3D([17501,17397,17068,17097],0); -ELEMENTS[3544] = Fluid3D([17917,17777,17983,17660],0); -ELEMENTS[3545] = Fluid3D([17890,17738,17823,18048],0); -ELEMENTS[3546] = Fluid3D([17823,18015,18048,17856],0); -ELEMENTS[3547] = Fluid3D([18015,17823,17697,17856],0); -ELEMENTS[3548] = Fluid3D([17890,17753,18021,17740],0); -ELEMENTS[3549] = Fluid3D([18020,18011,18045,18206],0); -ELEMENTS[3550] = Fluid3D([18011,18045,18206,18148],0); -ELEMENTS[3551] = Fluid3D([18011,18045,18148,17948],0); -ELEMENTS[3552] = Fluid3D([18020,17890,18021,18165],0); -ELEMENTS[3553] = Fluid3D([18021,18020,18165,18206],0); -ELEMENTS[3554] = Fluid3D([17528,17823,17856,17697],0); -ELEMENTS[3555] = Fluid3D([17528,17823,17697,17501],0); -ELEMENTS[3556] = Fluid3D([18045,18020,18206,18215],0); -ELEMENTS[3557] = Fluid3D([18045,18020,18215,17967],0); -ELEMENTS[3558] = Fluid3D([18045,18020,17967,17749],0); -ELEMENTS[3559] = Fluid3D([18045,18206,18148,18297],0); -ELEMENTS[3560] = Fluid3D([18206,18148,18297,18329],0); -ELEMENTS[3561] = Fluid3D([18148,18297,18329,18347],0); -ELEMENTS[3562] = Fluid3D([18148,18045,18297,18219],0); -ELEMENTS[3563] = Fluid3D([18206,18148,18329,18011],0); -ELEMENTS[3564] = Fluid3D([18206,18045,18215,18297],0); -ELEMENTS[3565] = Fluid3D([18015,18056,18048,18312],0); -ELEMENTS[3566] = Fluid3D([18056,17818,17917,18180],0); -ELEMENTS[3567] = Fluid3D([17917,18056,18180,18242],0); -ELEMENTS[3568] = Fluid3D([18020,17890,18165,18048],0); -ELEMENTS[3569] = Fluid3D([18215,18045,17967,18122],0); -ELEMENTS[3570] = Fluid3D([18215,18045,18122,18378],0); -ELEMENTS[3571] = Fluid3D([18045,17967,18122,17960],0); -ELEMENTS[3572] = Fluid3D([18122,18045,17960,18219],0); -ELEMENTS[3573] = Fluid3D([18045,17960,18219,17948],0); -ELEMENTS[3574] = Fluid3D([17960,18122,18219,18160],0); -ELEMENTS[3575] = Fluid3D([18045,17967,17960,17749],0); -ELEMENTS[3576] = Fluid3D([17960,18045,17749,17693],0); -ELEMENTS[3577] = Fluid3D([18056,17917,17983,18242],0); -ELEMENTS[3578] = Fluid3D([17381,17578,17749,17350],0); -ELEMENTS[3579] = Fluid3D([18020,17738,17890,18048],0); -ELEMENTS[3580] = Fluid3D([17818,18015,17697,17874],0); -ELEMENTS[3581] = Fluid3D([17697,17818,17874,17546],0); -ELEMENTS[3582] = Fluid3D([17818,18015,17874,18136],0); -ELEMENTS[3583] = Fluid3D([17874,17697,17546,17590],0); -ELEMENTS[3584] = Fluid3D([17697,17546,17590,17309],0); -ELEMENTS[3585] = Fluid3D([17697,17546,17309,17501],0); -ELEMENTS[3586] = Fluid3D([17874,17697,17590,17889],0); -ELEMENTS[3587] = Fluid3D([17874,17697,17889,18015],0); -ELEMENTS[3588] = Fluid3D([17697,17818,17546,17501],0); -ELEMENTS[3589] = Fluid3D([17818,17874,17546,17814],0); -ELEMENTS[3590] = Fluid3D([17818,17874,17814,18136],0); -ELEMENTS[3591] = Fluid3D([17546,17818,17814,17450],0); -ELEMENTS[3592] = Fluid3D([17381,17528,17578,17017],0); -ELEMENTS[3593] = Fluid3D([17818,18056,18015,18136],0); -ELEMENTS[3594] = Fluid3D([17890,18021,18165,18072],0); -ELEMENTS[3595] = Fluid3D([17350,17387,17467,16848],0); -ELEMENTS[3596] = Fluid3D([18020,18011,18206,18021],0); -ELEMENTS[3597] = Fluid3D([17578,17528,17856,17575],0); -ELEMENTS[3598] = Fluid3D([17528,17856,17575,17697],0); -ELEMENTS[3599] = Fluid3D([17578,17528,17575,17228],0); -ELEMENTS[3600] = Fluid3D([17578,17528,17228,17017],0); -ELEMENTS[3601] = Fluid3D([17528,17575,17228,17309],0); -ELEMENTS[3602] = Fluid3D([17575,17578,17228,17338],0); -ELEMENTS[3603] = Fluid3D([18020,18215,17967,18048],0); -ELEMENTS[3604] = Fluid3D([17467,17618,17481,17224],0); -ELEMENTS[3605] = Fluid3D([17568,17890,17627,17753],0); -ELEMENTS[3606] = Fluid3D([17697,17590,17889,17575],0); -ELEMENTS[3607] = Fluid3D([17890,17777,17627,17983],0); -ELEMENTS[3608] = Fluid3D([17697,17528,17501,17309],0); -ELEMENTS[3609] = Fluid3D([17960,17656,17749,17848],0); -ELEMENTS[3610] = Fluid3D([17656,17749,17848,17338],0); -ELEMENTS[3611] = Fluid3D([17749,17960,17848,17967],0); -ELEMENTS[3612] = Fluid3D([17960,17656,17848,17924],0); -ELEMENTS[3613] = Fluid3D([17840,17646,17879,17812],0); -ELEMENTS[3614] = Fluid3D([17646,17879,17812,17706],0); -ELEMENTS[3615] = Fluid3D([17812,17646,17706,17494],0); -ELEMENTS[3616] = Fluid3D([17812,17646,17494,17580],0); -ELEMENTS[3617] = Fluid3D([17812,17646,17580,17659],0); -ELEMENTS[3618] = Fluid3D([17646,17580,17659,17271],0); -ELEMENTS[3619] = Fluid3D([17580,17659,17271,17428],0); -ELEMENTS[3620] = Fluid3D([17646,17494,17580,17271],0); -ELEMENTS[3621] = Fluid3D([17646,17706,17494,17360],0); -ELEMENTS[3622] = Fluid3D([17494,17812,17580,17733],0); -ELEMENTS[3623] = Fluid3D([17646,17706,17360,17626],0); -ELEMENTS[3624] = Fluid3D([17494,17646,17360,17271],0); -ELEMENTS[3625] = Fluid3D([17580,17659,17428,17798],0); -ELEMENTS[3626] = Fluid3D([17580,17659,17798,17901],0); -ELEMENTS[3627] = Fluid3D([17580,17659,17901,17812],0); -ELEMENTS[3628] = Fluid3D([17798,17580,17901,17733],0); -ELEMENTS[3629] = Fluid3D([17798,17580,17733,17388],0); -ELEMENTS[3630] = Fluid3D([17798,17580,17388,17428],0); -ELEMENTS[3631] = Fluid3D([17733,17798,17388,17732],0); -ELEMENTS[3632] = Fluid3D([17733,17798,17732,18009],0); -ELEMENTS[3633] = Fluid3D([17733,17798,18009,17901],0); -ELEMENTS[3634] = Fluid3D([17798,17388,17732,17512],0); -ELEMENTS[3635] = Fluid3D([17798,17388,17512,17428],0); -ELEMENTS[3636] = Fluid3D([17812,17580,17733,17901],0); -ELEMENTS[3637] = Fluid3D([17494,17812,17733,17790],0); -ELEMENTS[3638] = Fluid3D([17732,17798,17512,18014],0); -ELEMENTS[3639] = Fluid3D([17494,17812,17790,17706],0); -ELEMENTS[3640] = Fluid3D([17812,17790,17706,18035],0); -ELEMENTS[3641] = Fluid3D([17812,17790,18035,18009],0); -ELEMENTS[3642] = Fluid3D([17580,17733,17388,17494],0); -ELEMENTS[3643] = Fluid3D([17388,17733,17732,17483],0); -ELEMENTS[3644] = Fluid3D([17812,17733,17790,18009],0); -ELEMENTS[3645] = Fluid3D([17812,17733,18009,17901],0); -ELEMENTS[3646] = Fluid3D([17733,17732,17483,17850],0); -ELEMENTS[3647] = Fluid3D([17733,17732,17850,18009],0); -ELEMENTS[3648] = Fluid3D([17840,17646,17812,17659],0); -ELEMENTS[3649] = Fluid3D([17388,17733,17483,17494],0); -ELEMENTS[3650] = Fluid3D([17388,17732,17512,17303],0); -ELEMENTS[3651] = Fluid3D([17512,17388,17303,17083],0); -ELEMENTS[3652] = Fluid3D([17512,17388,17083,17428],0); -ELEMENTS[3653] = Fluid3D([17646,17879,17706,17626],0); -ELEMENTS[3654] = Fluid3D([17733,17494,17790,17483],0); -ELEMENTS[3655] = Fluid3D([17732,17483,17850,17622],0); -ELEMENTS[3656] = Fluid3D([17388,17303,17083,17007],0); -ELEMENTS[3657] = Fluid3D([17706,17494,17360,17399],0); -ELEMENTS[3658] = Fluid3D([17494,17360,17399,17074],0); -ELEMENTS[3659] = Fluid3D([17494,17360,17074,17271],0); -ELEMENTS[3660] = Fluid3D([17388,17303,17007,17483],0); -ELEMENTS[3661] = Fluid3D([17083,17388,17007,17022],0); -ELEMENTS[3662] = Fluid3D([17083,17388,17022,17271],0); -ELEMENTS[3663] = Fluid3D([17388,17022,17271,17494],0); -ELEMENTS[3664] = Fluid3D([17388,17007,17022,17205],0); -ELEMENTS[3665] = Fluid3D([17388,17007,17205,17483],0); -ELEMENTS[3666] = Fluid3D([17732,17483,17622,17303],0); -ELEMENTS[3667] = Fluid3D([17388,17732,17303,17483],0); -ELEMENTS[3668] = Fluid3D([17790,18035,18009,18016],0); -ELEMENTS[3669] = Fluid3D([17790,18035,18016,17968],0); -ELEMENTS[3670] = Fluid3D([17360,17399,17074,17051],0); -ELEMENTS[3671] = Fluid3D([17360,17399,17051,17454],0); -ELEMENTS[3672] = Fluid3D([17074,17360,17051,17154],0); -ELEMENTS[3673] = Fluid3D([17360,17399,17454,17706],0); -ELEMENTS[3674] = Fluid3D([17051,17360,17454,17187],0); -ELEMENTS[3675] = Fluid3D([17051,17360,17187,17154],0); -ELEMENTS[3676] = Fluid3D([17360,17187,17154,17626],0); -ELEMENTS[3677] = Fluid3D([17483,17733,17850,17790],0); -ELEMENTS[3678] = Fluid3D([17790,17494,17706,17399],0); -ELEMENTS[3679] = Fluid3D([17303,17512,17083,17220],0); -ELEMENTS[3680] = Fluid3D([17512,17083,17220,17251],0); -ELEMENTS[3681] = Fluid3D([17303,17512,17220,17602],0); -ELEMENTS[3682] = Fluid3D([17512,17083,17251,17428],0); -ELEMENTS[3683] = Fluid3D([17251,17512,17428,17650],0); -ELEMENTS[3684] = Fluid3D([17428,17251,17650,17401],0); -ELEMENTS[3685] = Fluid3D([17428,17251,17401,16805],0); -ELEMENTS[3686] = Fluid3D([17251,17650,17401,17406],0); -ELEMENTS[3687] = Fluid3D([17251,17650,17406,17500],0); -ELEMENTS[3688] = Fluid3D([17251,17650,17500,17512],0); -ELEMENTS[3689] = Fluid3D([17401,17251,17406,17045],0); -ELEMENTS[3690] = Fluid3D([17406,17251,17500,17080],0); -ELEMENTS[3691] = Fluid3D([17303,17512,17602,17732],0); -ELEMENTS[3692] = Fluid3D([17650,17428,17401,17624],0); -ELEMENTS[3693] = Fluid3D([17512,17220,17602,17500],0); -ELEMENTS[3694] = Fluid3D([17220,17602,17500,17337],0); -ELEMENTS[3695] = Fluid3D([17500,17220,17337,17080],0); -ELEMENTS[3696] = Fluid3D([17512,17220,17500,17251],0); -ELEMENTS[3697] = Fluid3D([17220,17500,17251,17080],0); -ELEMENTS[3698] = Fluid3D([17220,17602,17337,17227],0); -ELEMENTS[3699] = Fluid3D([17337,17220,17227,16972],0); -ELEMENTS[3700] = Fluid3D([17337,17220,16972,17080],0); -ELEMENTS[3701] = Fluid3D([17220,17227,16972,16729],0); -ELEMENTS[3702] = Fluid3D([17227,17337,16972,17136],0); -ELEMENTS[3703] = Fluid3D([17337,16972,17136,17236],0); -ELEMENTS[3704] = Fluid3D([17602,17500,17337,17759],0); -ELEMENTS[3705] = Fluid3D([17500,17337,17759,17532],0); -ELEMENTS[3706] = Fluid3D([17500,17337,17532,17080],0); -ELEMENTS[3707] = Fluid3D([17759,17500,17532,17752],0); -ELEMENTS[3708] = Fluid3D([17759,17500,17752,17836],0); -ELEMENTS[3709] = Fluid3D([17500,17752,17836,17650],0); -ELEMENTS[3710] = Fluid3D([17836,17500,17650,17512],0); -ELEMENTS[3711] = Fluid3D([17220,17602,17227,17303],0); -ELEMENTS[3712] = Fluid3D([17227,17220,17303,16729],0); -ELEMENTS[3713] = Fluid3D([17759,17500,17836,17602],0); -ELEMENTS[3714] = Fluid3D([17337,17759,17532,17619],0); -ELEMENTS[3715] = Fluid3D([17532,17337,17619,17236],0); -ELEMENTS[3716] = Fluid3D([17337,17759,17619,17721],0); -ELEMENTS[3717] = Fluid3D([17619,17337,17721,17136],0); -ELEMENTS[3718] = Fluid3D([17337,17759,17721,17602],0); -ELEMENTS[3719] = Fluid3D([17650,17406,17500,17752],0); -ELEMENTS[3720] = Fluid3D([17227,17337,17136,17721],0); -ELEMENTS[3721] = Fluid3D([17752,17759,17836,18044],0); -ELEMENTS[3722] = Fluid3D([17759,17836,18044,17974],0); -ELEMENTS[3723] = Fluid3D([17759,17836,17974,17602],0); -ELEMENTS[3724] = Fluid3D([17500,17532,17752,17406],0); -ELEMENTS[3725] = Fluid3D([17850,17732,17622,17932],0); -ELEMENTS[3726] = Fluid3D([17850,17732,17932,17981],0); -ELEMENTS[3727] = Fluid3D([17732,17622,17932,17602],0); -ELEMENTS[3728] = Fluid3D([17732,17932,17981,17899],0); -ELEMENTS[3729] = Fluid3D([17732,17932,17899,17602],0); -ELEMENTS[3730] = Fluid3D([17981,17732,17899,18014],0); -ELEMENTS[3731] = Fluid3D([17899,17981,18014,18174],0); -ELEMENTS[3732] = Fluid3D([17981,18014,18174,18191],0); -ELEMENTS[3733] = Fluid3D([18174,17981,18191,17932],0); -ELEMENTS[3734] = Fluid3D([17981,18014,18191,18009],0); -ELEMENTS[3735] = Fluid3D([18191,17981,18009,17850],0); -ELEMENTS[3736] = Fluid3D([17981,18014,18009,17798],0); -ELEMENTS[3737] = Fluid3D([17981,18014,17798,17732],0); -ELEMENTS[3738] = Fluid3D([18014,17899,18174,18088],0); -ELEMENTS[3739] = Fluid3D([18174,18014,18088,18282],0); -ELEMENTS[3740] = Fluid3D([18014,17899,18088,17836],0); -ELEMENTS[3741] = Fluid3D([17899,18088,17836,17974],0); -ELEMENTS[3742] = Fluid3D([17836,17899,17974,17602],0); -ELEMENTS[3743] = Fluid3D([17836,17899,17602,17512],0); -ELEMENTS[3744] = Fluid3D([18014,17899,17836,17512],0); -ELEMENTS[3745] = Fluid3D([17899,17974,17602,17932],0); -ELEMENTS[3746] = Fluid3D([17899,17974,17932,18174],0); -ELEMENTS[3747] = Fluid3D([17899,17974,18174,18088],0); -ELEMENTS[3748] = Fluid3D([18088,18174,18282,18277],0); -ELEMENTS[3749] = Fluid3D([18174,18282,18277,18392],0); -ELEMENTS[3750] = Fluid3D([18174,18282,18392,18191],0); -ELEMENTS[3751] = Fluid3D([18174,18014,18282,18191],0); -ELEMENTS[3752] = Fluid3D([18277,18174,18392,18315],0); -ELEMENTS[3753] = Fluid3D([17899,17981,18174,17932],0); -ELEMENTS[3754] = Fluid3D([18174,18392,18315,18289],0); -ELEMENTS[3755] = Fluid3D([18174,18392,18289,18191],0); -ELEMENTS[3756] = Fluid3D([18289,18174,18191,17932],0); -ELEMENTS[3757] = Fluid3D([18392,18289,18191,18390],0); -ELEMENTS[3758] = Fluid3D([18289,18191,18390,18233],0); -ELEMENTS[3759] = Fluid3D([18392,18289,18390,18443],0); -ELEMENTS[3760] = Fluid3D([18289,18390,18443,18306],0); -ELEMENTS[3761] = Fluid3D([18289,18390,18306,18233],0); -ELEMENTS[3762] = Fluid3D([18282,18277,18392,18459],0); -ELEMENTS[3763] = Fluid3D([18392,18282,18459,18442],0); -ELEMENTS[3764] = Fluid3D([18392,18282,18442,18191],0); -ELEMENTS[3765] = Fluid3D([17981,18009,17850,17732],0); -ELEMENTS[3766] = Fluid3D([18277,18174,18315,17974],0); -ELEMENTS[3767] = Fluid3D([18088,18174,18277,17974],0); -ELEMENTS[3768] = Fluid3D([18282,18459,18442,18347],0); -ELEMENTS[3769] = Fluid3D([18442,18282,18347,18243],0); -ELEMENTS[3770] = Fluid3D([18392,18315,18289,18443],0); -ELEMENTS[3771] = Fluid3D([18315,18174,18289,17932],0); -ELEMENTS[3772] = Fluid3D([18392,18277,18315,18460],0); -ELEMENTS[3773] = Fluid3D([18277,18315,18460,18280],0); -ELEMENTS[3774] = Fluid3D([18315,18392,18460,18512],0); -ELEMENTS[3775] = Fluid3D([18277,18315,18280,17974],0); -ELEMENTS[3776] = Fluid3D([18459,18392,18442,18564],0); -ELEMENTS[3777] = Fluid3D([17932,17850,17981,18191],0); -ELEMENTS[3778] = Fluid3D([17622,17850,17932,17925],0); -ELEMENTS[3779] = Fluid3D([17850,17932,17925,18131],0); -ELEMENTS[3780] = Fluid3D([17850,17932,18131,18191],0); -ELEMENTS[3781] = Fluid3D([18282,18277,18459,18271],0); -ELEMENTS[3782] = Fluid3D([18282,18277,18271,18088],0); -ELEMENTS[3783] = Fluid3D([18459,18282,18271,18383],0); -ELEMENTS[3784] = Fluid3D([18282,18271,18383,18143],0); -ELEMENTS[3785] = Fluid3D([18459,18282,18383,18347],0); -ELEMENTS[3786] = Fluid3D([18282,18383,18347,18143],0); -ELEMENTS[3787] = Fluid3D([18383,18347,18143,18329],0); -ELEMENTS[3788] = Fluid3D([17271,17580,17428,17388],0); -ELEMENTS[3789] = Fluid3D([17271,17580,17388,17494],0); -ELEMENTS[3790] = Fluid3D([17752,17759,18044,17875],0); -ELEMENTS[3791] = Fluid3D([17759,18044,17875,18067],0); -ELEMENTS[3792] = Fluid3D([17759,18044,18067,17974],0); -ELEMENTS[3793] = Fluid3D([18035,18009,18016,18246],0); -ELEMENTS[3794] = Fluid3D([17399,17494,17074,17205],0); -ELEMENTS[3795] = Fluid3D([17494,17074,17205,17022],0); -ELEMENTS[3796] = Fluid3D([17074,17205,17022,16855],0); -ELEMENTS[3797] = Fluid3D([17074,17205,16855,16956],0); -ELEMENTS[3798] = Fluid3D([17074,17205,16956,17399],0); -ELEMENTS[3799] = Fluid3D([17205,16855,16956,17044],0); -ELEMENTS[3800] = Fluid3D([17205,16855,17044,17007],0); -ELEMENTS[3801] = Fluid3D([16855,17044,17007,16623],0); -ELEMENTS[3802] = Fluid3D([17044,17007,16623,17011],0); -ELEMENTS[3803] = Fluid3D([17044,17007,17011,17483],0); -ELEMENTS[3804] = Fluid3D([17044,17205,17007,17483],0); -ELEMENTS[3805] = Fluid3D([17205,16855,17007,17022],0); -ELEMENTS[3806] = Fluid3D([16956,17205,17044,17416],0); -ELEMENTS[3807] = Fluid3D([16956,17205,17416,17399],0); -ELEMENTS[3808] = Fluid3D([17007,16623,17011,16729],0); -ELEMENTS[3809] = Fluid3D([16623,17011,16729,16865],0); -ELEMENTS[3810] = Fluid3D([17011,16729,16865,17221],0); -ELEMENTS[3811] = Fluid3D([16865,17011,17221,17333],0); -ELEMENTS[3812] = Fluid3D([17011,16729,17221,17303],0); -ELEMENTS[3813] = Fluid3D([17221,17011,17303,17622],0); -ELEMENTS[3814] = Fluid3D([17007,16855,16623,16488],0); -ELEMENTS[3815] = Fluid3D([16855,16623,16488,16405],0); -ELEMENTS[3816] = Fluid3D([16488,16855,16405,16514],0); -ELEMENTS[3817] = Fluid3D([16623,17044,17011,16825],0); -ELEMENTS[3818] = Fluid3D([17044,17011,16825,17267],0); -ELEMENTS[3819] = Fluid3D([17044,17011,17267,17483],0); -ELEMENTS[3820] = Fluid3D([16623,17044,16825,16405],0); -ELEMENTS[3821] = Fluid3D([17205,17044,17416,17483],0); -ELEMENTS[3822] = Fluid3D([17044,17416,17483,17267],0); -ELEMENTS[3823] = Fluid3D([17416,17205,17483,17494],0); -ELEMENTS[3824] = Fluid3D([16855,17074,16956,16579],0); -ELEMENTS[3825] = Fluid3D([17074,16956,16579,17051],0); -ELEMENTS[3826] = Fluid3D([16855,17044,16623,16405],0); -ELEMENTS[3827] = Fluid3D([16825,17044,17267,17105],0); -ELEMENTS[3828] = Fluid3D([16825,17044,17105,16706],0); -ELEMENTS[3829] = Fluid3D([16825,17044,16706,16405],0); -ELEMENTS[3830] = Fluid3D([17044,17267,17105,17416],0); -ELEMENTS[3831] = Fluid3D([17044,16956,17416,17105],0); -ELEMENTS[3832] = Fluid3D([16855,17074,16579,16514],0); -ELEMENTS[3833] = Fluid3D([17011,16623,16825,16865],0); -ELEMENTS[3834] = Fluid3D([17105,16825,16706,16379],0); -ELEMENTS[3835] = Fluid3D([16855,16956,17044,16405],0); -ELEMENTS[3836] = Fluid3D([17011,16825,17267,16865],0); -ELEMENTS[3837] = Fluid3D([17044,17105,16706,16956],0); -ELEMENTS[3838] = Fluid3D([16706,17044,16956,16405],0); -ELEMENTS[3839] = Fluid3D([17267,16825,17105,16897],0); -ELEMENTS[3840] = Fluid3D([16956,16855,16579,16405],0); -ELEMENTS[3841] = Fluid3D([17011,17007,16729,17303],0); -ELEMENTS[3842] = Fluid3D([17011,17007,17303,17483],0); -ELEMENTS[3843] = Fluid3D([17399,17051,17454,17280],0); -ELEMENTS[3844] = Fluid3D([17454,17399,17280,17609],0); -ELEMENTS[3845] = Fluid3D([17399,17051,17280,16988],0); -ELEMENTS[3846] = Fluid3D([17399,17051,16988,16956],0); -ELEMENTS[3847] = Fluid3D([16988,17399,16956,17339],0); -ELEMENTS[3848] = Fluid3D([16956,16988,17339,16925],0); -ELEMENTS[3849] = Fluid3D([16956,16988,16925,16579],0); -ELEMENTS[3850] = Fluid3D([16956,16988,16579,17051],0); -ELEMENTS[3851] = Fluid3D([16988,17339,16925,17094],0); -ELEMENTS[3852] = Fluid3D([16988,17339,17094,17280],0); -ELEMENTS[3853] = Fluid3D([16925,16988,17094,16675],0); -ELEMENTS[3854] = Fluid3D([16925,16988,16675,16579],0); -ELEMENTS[3855] = Fluid3D([16988,17094,16675,17280],0); -ELEMENTS[3856] = Fluid3D([17339,16956,16925,17105],0); -ELEMENTS[3857] = Fluid3D([17094,16925,16675,16668],0); -ELEMENTS[3858] = Fluid3D([16925,16675,16668,16441],0); -ELEMENTS[3859] = Fluid3D([16925,16675,16441,16579],0); -ELEMENTS[3860] = Fluid3D([16675,16668,16441,16272],0); -ELEMENTS[3861] = Fluid3D([16441,16675,16272,16007],0); -ELEMENTS[3862] = Fluid3D([16988,17399,17339,17280],0); -ELEMENTS[3863] = Fluid3D([16675,16272,16007,16297],0); -ELEMENTS[3864] = Fluid3D([16441,16675,16007,16579],0); -ELEMENTS[3865] = Fluid3D([16675,16668,16272,16778],0); -ELEMENTS[3866] = Fluid3D([16675,16668,16778,17094],0); -ELEMENTS[3867] = Fluid3D([17094,16925,16668,17183],0); -ELEMENTS[3868] = Fluid3D([17094,16925,17183,17339],0); -ELEMENTS[3869] = Fluid3D([16925,16668,17183,16806],0); -ELEMENTS[3870] = Fluid3D([16925,16668,16806,16441],0); -ELEMENTS[3871] = Fluid3D([17183,16925,16806,17105],0); -ELEMENTS[3872] = Fluid3D([16272,16441,16007,15775],0); -ELEMENTS[3873] = Fluid3D([16668,16441,16272,16372],0); -ELEMENTS[3874] = Fluid3D([17051,17454,17280,17120],0); -ELEMENTS[3875] = Fluid3D([17051,17280,16988,16772],0); -ELEMENTS[3876] = Fluid3D([17051,17280,16772,17120],0); -ELEMENTS[3877] = Fluid3D([17051,17454,17120,17187],0); -ELEMENTS[3878] = Fluid3D([16668,16441,16372,16806],0); -ELEMENTS[3879] = Fluid3D([17454,17399,17609,17706],0); -ELEMENTS[3880] = Fluid3D([17303,17083,17007,16729],0); -ELEMENTS[3881] = Fluid3D([17399,17280,17609,17339],0); -ELEMENTS[3882] = Fluid3D([17483,17850,17622,17607],0); -ELEMENTS[3883] = Fluid3D([17850,17622,17607,17925],0); -ELEMENTS[3884] = Fluid3D([17622,17483,17607,17267],0); -ELEMENTS[3885] = Fluid3D([17483,17850,17607,17416],0); -ELEMENTS[3886] = Fluid3D([17607,17483,17416,17267],0); -ELEMENTS[3887] = Fluid3D([17007,17083,17022,16582],0); -ELEMENTS[3888] = Fluid3D([17083,17022,16582,16805],0); -ELEMENTS[3889] = Fluid3D([17007,17083,16582,16729],0); -ELEMENTS[3890] = Fluid3D([17022,17007,16582,16488],0); -ELEMENTS[3891] = Fluid3D([17399,17074,17051,16956],0); -ELEMENTS[3892] = Fluid3D([17022,17388,17205,17494],0); -ELEMENTS[3893] = Fluid3D([17360,17454,17187,17582],0); -ELEMENTS[3894] = Fluid3D([17360,17454,17582,17706],0); -ELEMENTS[3895] = Fluid3D([17187,17360,17582,17626],0); -ELEMENTS[3896] = Fluid3D([17360,17582,17626,17706],0); -ELEMENTS[3897] = Fluid3D([17454,17187,17582,17478],0); -ELEMENTS[3898] = Fluid3D([17582,17454,17478,17825],0); -ELEMENTS[3899] = Fluid3D([17582,17454,17825,17706],0); -ELEMENTS[3900] = Fluid3D([17454,17187,17478,17120],0); -ELEMENTS[3901] = Fluid3D([17478,17582,17825,17845],0); -ELEMENTS[3902] = Fluid3D([17582,17825,17845,17879],0); -ELEMENTS[3903] = Fluid3D([17478,17582,17845,17430],0); -ELEMENTS[3904] = Fluid3D([17478,17582,17430,17187],0); -ELEMENTS[3905] = Fluid3D([17582,17845,17430,17626],0); -ELEMENTS[3906] = Fluid3D([17430,17582,17626,17187],0); -ELEMENTS[3907] = Fluid3D([17825,17478,17845,17783],0); -ELEMENTS[3908] = Fluid3D([17845,17825,17783,18167],0); -ELEMENTS[3909] = Fluid3D([17478,17845,17783,17573],0); -ELEMENTS[3910] = Fluid3D([17478,17845,17573,17430],0); -ELEMENTS[3911] = Fluid3D([17845,17783,17573,17969],0); -ELEMENTS[3912] = Fluid3D([17845,17783,17969,18167],0); -ELEMENTS[3913] = Fluid3D([17825,17478,17783,17576],0); -ELEMENTS[3914] = Fluid3D([17783,17825,17576,17976],0); -ELEMENTS[3915] = Fluid3D([17825,17478,17576,17454],0); -ELEMENTS[3916] = Fluid3D([17783,17573,17969,17760],0); -ELEMENTS[3917] = Fluid3D([17783,17573,17760,17463],0); -ELEMENTS[3918] = Fluid3D([17573,17969,17760,17734],0); -ELEMENTS[3919] = Fluid3D([17573,17969,17734,17750],0); -ELEMENTS[3920] = Fluid3D([17573,17969,17750,17845],0); -ELEMENTS[3921] = Fluid3D([17969,17734,17750,18010],0); -ELEMENTS[3922] = Fluid3D([17969,17734,18010,18073],0); -ELEMENTS[3923] = Fluid3D([17750,17969,18010,18039],0); -ELEMENTS[3924] = Fluid3D([17750,17969,18039,17845],0); -ELEMENTS[3925] = Fluid3D([17573,17760,17463,17409],0); -ELEMENTS[3926] = Fluid3D([17969,18010,18039,18255],0); -ELEMENTS[3927] = Fluid3D([17760,17463,17409,17529],0); -ELEMENTS[3928] = Fluid3D([17760,17463,17529,17916],0); -ELEMENTS[3929] = Fluid3D([17463,17409,17529,17128],0); -ELEMENTS[3930] = Fluid3D([17463,17409,17128,17138],0); -ELEMENTS[3931] = Fluid3D([17463,17409,17138,17573],0); -ELEMENTS[3932] = Fluid3D([17573,17760,17409,17734],0); -ELEMENTS[3933] = Fluid3D([17409,17529,17128,17247],0); -ELEMENTS[3934] = Fluid3D([17409,17529,17247,17605],0); -ELEMENTS[3935] = Fluid3D([17529,17128,17247,17207],0); -ELEMENTS[3936] = Fluid3D([17409,17529,17605,17760],0); -ELEMENTS[3937] = Fluid3D([17247,17409,17605,17344],0); -ELEMENTS[3938] = Fluid3D([17247,17409,17344,16985],0); -ELEMENTS[3939] = Fluid3D([17247,17409,16985,17128],0); -ELEMENTS[3940] = Fluid3D([17529,17128,17207,17334],0); -ELEMENTS[3941] = Fluid3D([17529,17128,17334,17463],0); -ELEMENTS[3942] = Fluid3D([17605,17247,17344,17438],0); -ELEMENTS[3943] = Fluid3D([17247,17344,17438,17020],0); -ELEMENTS[3944] = Fluid3D([17247,17344,17020,16985],0); -ELEMENTS[3945] = Fluid3D([17207,17529,17334,17680],0); -ELEMENTS[3946] = Fluid3D([17529,17334,17680,17742],0); -ELEMENTS[3947] = Fluid3D([17605,17247,17438,17491],0); -ELEMENTS[3948] = Fluid3D([17605,17247,17491,17529],0); -ELEMENTS[3949] = Fluid3D([17247,17438,17491,17171],0); -ELEMENTS[3950] = Fluid3D([17247,17438,17171,17020],0); -ELEMENTS[3951] = Fluid3D([17438,17491,17171,17524],0); -ELEMENTS[3952] = Fluid3D([17171,17438,17524,17206],0); -ELEMENTS[3953] = Fluid3D([17171,17438,17206,17020],0); -ELEMENTS[3954] = Fluid3D([17438,17491,17524,17807],0); -ELEMENTS[3955] = Fluid3D([17491,17524,17807,17562],0); -ELEMENTS[3956] = Fluid3D([17524,17807,17562,17762],0); -ELEMENTS[3957] = Fluid3D([17562,17524,17762,17516],0); -ELEMENTS[3958] = Fluid3D([17491,17524,17562,17171],0); -ELEMENTS[3959] = Fluid3D([17524,17807,17762,17758],0); -ELEMENTS[3960] = Fluid3D([17762,17524,17758,17396],0); -ELEMENTS[3961] = Fluid3D([17762,17524,17396,17516],0); -ELEMENTS[3962] = Fluid3D([17524,17807,17758,17438],0); -ELEMENTS[3963] = Fluid3D([17758,17524,17438,17206],0); -ELEMENTS[3964] = Fluid3D([17524,17758,17396,17206],0); -ELEMENTS[3965] = Fluid3D([17396,17524,17206,17231],0); -ELEMENTS[3966] = Fluid3D([17206,17396,17231,17091],0); -ELEMENTS[3967] = Fluid3D([17206,17396,17091,17294],0); -ELEMENTS[3968] = Fluid3D([17206,17396,17294,17758],0); -ELEMENTS[3969] = Fluid3D([17396,17231,17091,17402],0); -ELEMENTS[3970] = Fluid3D([17396,17091,17294,17547],0); -ELEMENTS[3971] = Fluid3D([17091,17206,17294,16868],0); -ELEMENTS[3972] = Fluid3D([17396,17524,17231,17516],0); -ELEMENTS[3973] = Fluid3D([17396,17231,17402,17516],0); -ELEMENTS[3974] = Fluid3D([17231,17402,17516,17235],0); -ELEMENTS[3975] = Fluid3D([17231,17206,17091,16820],0); -ELEMENTS[3976] = Fluid3D([17396,17091,17547,17402],0); -ELEMENTS[3977] = Fluid3D([17091,17206,16868,16820],0); -ELEMENTS[3978] = Fluid3D([17294,17396,17547,17699],0); -ELEMENTS[3979] = Fluid3D([17294,17396,17699,17758],0); -ELEMENTS[3980] = Fluid3D([17206,17294,16868,17157],0); -ELEMENTS[3981] = Fluid3D([17206,17294,17157,17758],0); -ELEMENTS[3982] = Fluid3D([17231,17206,16820,17171],0); -ELEMENTS[3983] = Fluid3D([17396,17547,17699,17718],0); -ELEMENTS[3984] = Fluid3D([16868,17206,17157,17020],0); -ELEMENTS[3985] = Fluid3D([17206,17157,17020,17438],0); -ELEMENTS[3986] = Fluid3D([17157,17020,17438,17344],0); -ELEMENTS[3987] = Fluid3D([17547,17396,17402,17718],0); -ELEMENTS[3988] = Fluid3D([17524,17206,17231,17171],0); -ELEMENTS[3989] = Fluid3D([17758,17762,17396,17954],0); -ELEMENTS[3990] = Fluid3D([17294,16868,17157,16998],0); -ELEMENTS[3991] = Fluid3D([17091,17294,17547,17053],0); -ELEMENTS[3992] = Fluid3D([17294,16868,16998,17053],0); -ELEMENTS[3993] = Fluid3D([17547,17091,17053,17108],0); -ELEMENTS[3994] = Fluid3D([17547,17091,17108,17402],0); -ELEMENTS[3995] = Fluid3D([17053,17547,17108,17323],0); -ELEMENTS[3996] = Fluid3D([17053,17547,17323,17485],0); -ELEMENTS[3997] = Fluid3D([17053,17547,17485,17294],0); -ELEMENTS[3998] = Fluid3D([17547,17108,17323,17550],0); -ELEMENTS[3999] = Fluid3D([17547,17108,17550,17402],0); -ELEMENTS[4000] = Fluid3D([17091,17231,16820,16909],0); -ELEMENTS[4001] = Fluid3D([16820,17091,16909,16624],0); -ELEMENTS[4002] = Fluid3D([17231,16820,16909,16872],0); -ELEMENTS[4003] = Fluid3D([17231,16820,16872,17171],0); -ELEMENTS[4004] = Fluid3D([16820,16909,16872,16363],0); -ELEMENTS[4005] = Fluid3D([16820,16909,16363,16624],0); -ELEMENTS[4006] = Fluid3D([16820,17091,16624,16868],0); -ELEMENTS[4007] = Fluid3D([17547,17294,17699,17485],0); -ELEMENTS[4008] = Fluid3D([17157,17294,16998,17415],0); -ELEMENTS[4009] = Fluid3D([17157,17294,17415,17758],0); -ELEMENTS[4010] = Fluid3D([17294,16998,17415,17485],0); -ELEMENTS[4011] = Fluid3D([16998,17157,17415,17116],0); -ELEMENTS[4012] = Fluid3D([17157,17415,17116,17448],0); -ELEMENTS[4013] = Fluid3D([17157,17415,17448,17438],0); -ELEMENTS[4014] = Fluid3D([16998,17157,17116,16727],0); -ELEMENTS[4015] = Fluid3D([17294,17091,16868,17053],0); -ELEMENTS[4016] = Fluid3D([17231,17091,17402,16909],0); -ELEMENTS[4017] = Fluid3D([16868,17157,16998,16727],0); -ELEMENTS[4018] = Fluid3D([17108,17053,17323,16814],0); -ELEMENTS[4019] = Fluid3D([17323,17108,16814,17070],0); -ELEMENTS[4020] = Fluid3D([17323,17108,17070,17550],0); -ELEMENTS[4021] = Fluid3D([17108,17053,16814,16624],0); -ELEMENTS[4022] = Fluid3D([17206,16868,16820,17020],0); -ELEMENTS[4023] = Fluid3D([17478,17783,17576,17463],0); -ELEMENTS[4024] = Fluid3D([17783,17573,17463,17478],0); -ELEMENTS[4025] = Fluid3D([17969,17760,17734,18073],0); -ELEMENTS[4026] = Fluid3D([17969,17783,17760,18126],0); -ELEMENTS[4027] = Fluid3D([17760,17783,17463,17916],0); -ELEMENTS[4028] = Fluid3D([17760,17783,17916,18126],0); -ELEMENTS[4029] = Fluid3D([17083,17303,17220,16729],0); -ELEMENTS[4030] = Fluid3D([17734,17750,18010,17746],0); -ELEMENTS[4031] = Fluid3D([18010,17734,17746,17920],0); -ELEMENTS[4032] = Fluid3D([17750,18010,17746,17993],0); -ELEMENTS[4033] = Fluid3D([17746,18010,17920,18036],0); -ELEMENTS[4034] = Fluid3D([17734,17750,17746,17452],0); -ELEMENTS[4035] = Fluid3D([17746,17734,17452,17535],0); -ELEMENTS[4036] = Fluid3D([17746,17734,17535,17920],0); -ELEMENTS[4037] = Fluid3D([17734,17750,17452,17573],0); -ELEMENTS[4038] = Fluid3D([17746,17750,17993,17574],0); -ELEMENTS[4039] = Fluid3D([17750,17993,17574,17779],0); -ELEMENTS[4040] = Fluid3D([17750,17993,17779,18039],0); -ELEMENTS[4041] = Fluid3D([17993,17574,17779,17773],0); -ELEMENTS[4042] = Fluid3D([17993,17574,17773,17806],0); -ELEMENTS[4043] = Fluid3D([17993,17574,17806,17746],0); -ELEMENTS[4044] = Fluid3D([17746,17750,17574,17452],0); -ELEMENTS[4045] = Fluid3D([17574,17779,17773,17499],0); -ELEMENTS[4046] = Fluid3D([17773,17574,17499,17477],0); -ELEMENTS[4047] = Fluid3D([17773,17574,17477,17806],0); -ELEMENTS[4048] = Fluid3D([17499,17773,17477,17575],0); -ELEMENTS[4049] = Fluid3D([17574,17779,17499,17536],0); -ELEMENTS[4050] = Fluid3D([17779,17499,17536,17656],0); -ELEMENTS[4051] = Fluid3D([17499,17574,17536,17186],0); -ELEMENTS[4052] = Fluid3D([17536,17499,17186,17024],0); -ELEMENTS[4053] = Fluid3D([17186,17536,17024,17140],0); -ELEMENTS[4054] = Fluid3D([17024,17186,17140,16743],0); -ELEMENTS[4055] = Fluid3D([17024,17186,16743,16866],0); -ELEMENTS[4056] = Fluid3D([17186,17140,16743,17118],0); -ELEMENTS[4057] = Fluid3D([17186,17140,17118,17452],0); -ELEMENTS[4058] = Fluid3D([16743,17186,17118,16958],0); -ELEMENTS[4059] = Fluid3D([16743,17186,16958,16866],0); -ELEMENTS[4060] = Fluid3D([17186,17118,16958,17394],0); -ELEMENTS[4061] = Fluid3D([17186,17118,17394,17452],0); -ELEMENTS[4062] = Fluid3D([16958,17186,17394,17477],0); -ELEMENTS[4063] = Fluid3D([17186,17394,17477,17574],0); -ELEMENTS[4064] = Fluid3D([17394,17477,17574,17806],0); -ELEMENTS[4065] = Fluid3D([17186,17394,17574,17452],0); -ELEMENTS[4066] = Fluid3D([17394,17477,17806,17507],0); -ELEMENTS[4067] = Fluid3D([17394,17477,17507,16958],0); -ELEMENTS[4068] = Fluid3D([17140,17024,16743,16704],0); -ELEMENTS[4069] = Fluid3D([17186,17536,17140,17574],0); -ELEMENTS[4070] = Fluid3D([17140,16743,17118,16705],0); -ELEMENTS[4071] = Fluid3D([17118,17140,16705,17151],0); -ELEMENTS[4072] = Fluid3D([17118,17140,17151,17452],0); -ELEMENTS[4073] = Fluid3D([17140,17151,17452,17138],0); -ELEMENTS[4074] = Fluid3D([17151,17118,17452,17535],0); -ELEMENTS[4075] = Fluid3D([17024,16743,16704,16565],0); -ELEMENTS[4076] = Fluid3D([16705,17118,17151,16914],0); -ELEMENTS[4077] = Fluid3D([16705,17118,16914,16570],0); -ELEMENTS[4078] = Fluid3D([16705,17118,16570,16743],0); -ELEMENTS[4079] = Fluid3D([17499,17574,17186,17477],0); -ELEMENTS[4080] = Fluid3D([17118,16958,17394,17049],0); -ELEMENTS[4081] = Fluid3D([17394,17118,17049,17324],0); -ELEMENTS[4082] = Fluid3D([17118,16958,17049,16570],0); -ELEMENTS[4083] = Fluid3D([16958,17394,17049,17507],0); -ELEMENTS[4084] = Fluid3D([17394,17118,17324,17535],0); -ELEMENTS[4085] = Fluid3D([17118,17049,17324,16914],0); -ELEMENTS[4086] = Fluid3D([17118,16914,16570,17049],0); -ELEMENTS[4087] = Fluid3D([17118,16743,16958,16570],0); -ELEMENTS[4088] = Fluid3D([17140,16743,16705,16704],0); -ELEMENTS[4089] = Fluid3D([17118,17151,16914,17535],0); -ELEMENTS[4090] = Fluid3D([17574,17394,17806,17746],0); -ELEMENTS[4091] = Fluid3D([17140,16705,17151,17138],0); -ELEMENTS[4092] = Fluid3D([17049,17394,17324,17435],0); -ELEMENTS[4093] = Fluid3D([17394,17324,17435,17601],0); -ELEMENTS[4094] = Fluid3D([17394,17324,17601,17535],0); -ELEMENTS[4095] = Fluid3D([17435,17394,17601,17507],0); -ELEMENTS[4096] = Fluid3D([17435,17394,17507,17049],0); -ELEMENTS[4097] = Fluid3D([17324,17435,17601,17535],0); -ELEMENTS[4098] = Fluid3D([17601,17435,17507,17843],0); -ELEMENTS[4099] = Fluid3D([17435,17507,17843,17373],0); -ELEMENTS[4100] = Fluid3D([17435,17507,17373,17162],0); -ELEMENTS[4101] = Fluid3D([17435,17507,17162,17049],0); -ELEMENTS[4102] = Fluid3D([17162,17435,17049,17148],0); -ELEMENTS[4103] = Fluid3D([17049,17162,17148,16726],0); -ELEMENTS[4104] = Fluid3D([17049,17162,16726,16822],0); -ELEMENTS[4105] = Fluid3D([17049,17162,16822,16958],0); -ELEMENTS[4106] = Fluid3D([16822,17049,16958,16570],0); -ELEMENTS[4107] = Fluid3D([17601,17435,17843,17692],0); -ELEMENTS[4108] = Fluid3D([17601,17435,17692,17535],0); -ELEMENTS[4109] = Fluid3D([17843,17435,17373,17692],0); -ELEMENTS[4110] = Fluid3D([17373,17435,17162,17148],0); -ELEMENTS[4111] = Fluid3D([17507,17373,17162,17342],0); -ELEMENTS[4112] = Fluid3D([17162,17148,16726,17060],0); -ELEMENTS[4113] = Fluid3D([17162,17507,17342,17160],0); -ELEMENTS[4114] = Fluid3D([17162,16726,16822,16883],0); -ELEMENTS[4115] = Fluid3D([17162,17507,17160,16958],0); -ELEMENTS[4116] = Fluid3D([16726,17162,17060,16883],0); -ELEMENTS[4117] = Fluid3D([17507,17373,17342,17755],0); -ELEMENTS[4118] = Fluid3D([16822,17162,16883,17160],0); -ELEMENTS[4119] = Fluid3D([16822,17162,17160,16958],0); -ELEMENTS[4120] = Fluid3D([17160,16822,16958,16661],0); -ELEMENTS[4121] = Fluid3D([17148,17049,16726,16830],0); -ELEMENTS[4122] = Fluid3D([17162,17148,17060,17373],0); -ELEMENTS[4123] = Fluid3D([16726,17049,16822,16570],0); -ELEMENTS[4124] = Fluid3D([17507,17373,17755,17843],0); -ELEMENTS[4125] = Fluid3D([17049,16726,16830,16570],0); -ELEMENTS[4126] = Fluid3D([17148,17049,16830,17253],0); -ELEMENTS[4127] = Fluid3D([17342,17507,17755,17564],0); -ELEMENTS[4128] = Fluid3D([17435,17049,17148,17253],0); -ELEMENTS[4129] = Fluid3D([17049,16830,17253,16914],0); -ELEMENTS[4130] = Fluid3D([17507,17342,17160,17564],0); -ELEMENTS[4131] = Fluid3D([17507,17755,17564,17821],0); -ELEMENTS[4132] = Fluid3D([17564,17507,17821,17477],0); -ELEMENTS[4133] = Fluid3D([17162,17060,16883,17342],0); -ELEMENTS[4134] = Fluid3D([17373,17162,17342,17060],0); -ELEMENTS[4135] = Fluid3D([17507,17755,17821,17843],0); -ELEMENTS[4136] = Fluid3D([17342,17162,17160,16883],0); -ELEMENTS[4137] = Fluid3D([16726,17148,16830,16945],0); -ELEMENTS[4138] = Fluid3D([16830,16726,16945,16365],0); -ELEMENTS[4139] = Fluid3D([17148,16830,16945,17116],0); -ELEMENTS[4140] = Fluid3D([16830,16726,16365,16570],0); -ELEMENTS[4141] = Fluid3D([16945,16830,16365,16560],0); -ELEMENTS[4142] = Fluid3D([16945,16830,16560,17116],0); -ELEMENTS[4143] = Fluid3D([17373,17342,17755,17608],0); -ELEMENTS[4144] = Fluid3D([17755,17373,17608,17868],0); -ELEMENTS[4145] = Fluid3D([17755,17373,17868,17843],0); -ELEMENTS[4146] = Fluid3D([17373,17342,17608,17237],0); -ELEMENTS[4147] = Fluid3D([17608,17373,17237,17565],0); -ELEMENTS[4148] = Fluid3D([17608,17755,17868,17946],0); -ELEMENTS[4149] = Fluid3D([17608,17373,17565,17868],0); -ELEMENTS[4150] = Fluid3D([17755,17868,17946,18057],0); -ELEMENTS[4151] = Fluid3D([17755,17868,18057,17843],0); -ELEMENTS[4152] = Fluid3D([17373,17342,17237,17060],0); -ELEMENTS[4153] = Fluid3D([17237,17373,17060,17565],0); -ELEMENTS[4154] = Fluid3D([17148,16726,17060,16945],0); -ELEMENTS[4155] = Fluid3D([17755,17342,17564,17638],0); -ELEMENTS[4156] = Fluid3D([17342,17564,17638,17264],0); -ELEMENTS[4157] = Fluid3D([17342,17564,17264,17160],0); -ELEMENTS[4158] = Fluid3D([16726,16822,16883,16368],0); -ELEMENTS[4159] = Fluid3D([16883,16726,16368,16527],0); -ELEMENTS[4160] = Fluid3D([16883,16726,16527,17060],0); -ELEMENTS[4161] = Fluid3D([16822,16883,16368,16591],0); -ELEMENTS[4162] = Fluid3D([16822,16883,16591,17160],0); -ELEMENTS[4163] = Fluid3D([16883,16368,16591,16369],0); -ELEMENTS[4164] = Fluid3D([16883,16368,16369,16527],0); -ELEMENTS[4165] = Fluid3D([16830,17148,17253,17116],0); -ELEMENTS[4166] = Fluid3D([17253,16830,17116,16914],0); -ELEMENTS[4167] = Fluid3D([17755,17564,17821,17889],0); -ELEMENTS[4168] = Fluid3D([17151,16705,16914,16985],0); -ELEMENTS[4169] = Fluid3D([17499,17186,17024,16866],0); -ELEMENTS[4170] = Fluid3D([17394,17601,17507,17806],0); -ELEMENTS[4171] = Fluid3D([17394,17601,17806,17746],0); -ELEMENTS[4172] = Fluid3D([17601,17806,17746,18036],0); -ELEMENTS[4173] = Fluid3D([17601,17507,17806,17843],0); -ELEMENTS[4174] = Fluid3D([17806,17601,17843,18036],0); -ELEMENTS[4175] = Fluid3D([17394,17601,17746,17535],0); -ELEMENTS[4176] = Fluid3D([17746,17601,18036,17692],0); -ELEMENTS[4177] = Fluid3D([17507,17806,17843,17821],0); -ELEMENTS[4178] = Fluid3D([17806,17843,17821,18099],0); -ELEMENTS[4179] = Fluid3D([17821,17806,18099,17773],0); -ELEMENTS[4180] = Fluid3D([17821,17806,17773,17477],0); -ELEMENTS[4181] = Fluid3D([17507,17806,17821,17477],0); -ELEMENTS[4182] = Fluid3D([17806,17843,18099,18036],0); -ELEMENTS[4183] = Fluid3D([17452,17151,17535,17409],0); -ELEMENTS[4184] = Fluid3D([17601,17746,17535,17692],0); -ELEMENTS[4185] = Fluid3D([17750,18010,17993,18039],0); -ELEMENTS[4186] = Fluid3D([17746,18010,18036,17993],0); -ELEMENTS[4187] = Fluid3D([17920,17746,18036,17692],0); -ELEMENTS[4188] = Fluid3D([17342,17608,17237,17273],0); -ELEMENTS[4189] = Fluid3D([17237,17342,17273,16883],0); -ELEMENTS[4190] = Fluid3D([17608,17237,17273,17405],0); -ELEMENTS[4191] = Fluid3D([17608,17237,17405,17565],0); -ELEMENTS[4192] = Fluid3D([17342,17608,17273,17638],0); -ELEMENTS[4193] = Fluid3D([17273,17608,17405,17591],0); -ELEMENTS[4194] = Fluid3D([17405,17273,17591,17252],0); -ELEMENTS[4195] = Fluid3D([17405,17273,17252,16977],0); -ELEMENTS[4196] = Fluid3D([17405,17273,16977,17237],0); -ELEMENTS[4197] = Fluid3D([17273,17252,16977,16949],0); -ELEMENTS[4198] = Fluid3D([16977,17273,16949,16947],0); -ELEMENTS[4199] = Fluid3D([16977,17273,16947,16883],0); -ELEMENTS[4200] = Fluid3D([17273,17252,16949,17354],0); -ELEMENTS[4201] = Fluid3D([17273,17252,17354,17591],0); -ELEMENTS[4202] = Fluid3D([17252,16949,17354,17078],0); -ELEMENTS[4203] = Fluid3D([17354,17252,17078,17510],0); -ELEMENTS[4204] = Fluid3D([17354,17252,17510,17591],0); -ELEMENTS[4205] = Fluid3D([17252,16949,17078,16834],0); -ELEMENTS[4206] = Fluid3D([16949,17078,16834,16609],0); -ELEMENTS[4207] = Fluid3D([16949,17078,16609,16954],0); -ELEMENTS[4208] = Fluid3D([16949,17078,16954,17354],0); -ELEMENTS[4209] = Fluid3D([17252,16949,16834,16977],0); -ELEMENTS[4210] = Fluid3D([17273,17608,17591,17638],0); -ELEMENTS[4211] = Fluid3D([17608,17405,17591,17863],0); -ELEMENTS[4212] = Fluid3D([17608,17405,17863,17565],0); -ELEMENTS[4213] = Fluid3D([17405,17591,17863,17666],0); -ELEMENTS[4214] = Fluid3D([17405,17591,17666,17252],0); -ELEMENTS[4215] = Fluid3D([17863,17405,17666,17558],0); -ELEMENTS[4216] = Fluid3D([17863,17405,17558,17565],0); -ELEMENTS[4217] = Fluid3D([17405,17666,17558,17248],0); -ELEMENTS[4218] = Fluid3D([17405,17666,17248,17252],0); -ELEMENTS[4219] = Fluid3D([17558,17405,17248,17258],0); -ELEMENTS[4220] = Fluid3D([17558,17405,17258,17565],0); -ELEMENTS[4221] = Fluid3D([17405,17248,17258,16977],0); -ELEMENTS[4222] = Fluid3D([17666,17558,17248,17572],0); -ELEMENTS[4223] = Fluid3D([17248,17666,17572,17377],0); -ELEMENTS[4224] = Fluid3D([17248,17666,17377,17252],0); -ELEMENTS[4225] = Fluid3D([17558,17248,17572,17341],0); -ELEMENTS[4226] = Fluid3D([17558,17248,17341,17258],0); -ELEMENTS[4227] = Fluid3D([17666,17558,17572,17953],0); -ELEMENTS[4228] = Fluid3D([17248,17572,17341,17188],0); -ELEMENTS[4229] = Fluid3D([17248,17572,17188,17377],0); -ELEMENTS[4230] = Fluid3D([17341,17248,17188,16870],0); -ELEMENTS[4231] = Fluid3D([17341,17248,16870,17258],0); -ELEMENTS[4232] = Fluid3D([17248,17188,16870,16886],0); -ELEMENTS[4233] = Fluid3D([17248,17188,16886,17377],0); -ELEMENTS[4234] = Fluid3D([17572,17341,17188,17484],0); -ELEMENTS[4235] = Fluid3D([17572,17341,17484,17715],0); -ELEMENTS[4236] = Fluid3D([17572,17341,17715,17558],0); -ELEMENTS[4237] = Fluid3D([17188,16870,16886,16720],0); -ELEMENTS[4238] = Fluid3D([17341,17188,17484,17076],0); -ELEMENTS[4239] = Fluid3D([17188,16870,16720,17076],0); -ELEMENTS[4240] = Fluid3D([17341,17188,17076,16870],0); -ELEMENTS[4241] = Fluid3D([16870,16886,16720,16450],0); -ELEMENTS[4242] = Fluid3D([16886,16720,16450,16434],0); -ELEMENTS[4243] = Fluid3D([16886,16720,16434,16931],0); -ELEMENTS[4244] = Fluid3D([16886,16720,16931,17188],0); -ELEMENTS[4245] = Fluid3D([16870,16886,16450,16783],0); -ELEMENTS[4246] = Fluid3D([16870,16886,16783,17248],0); -ELEMENTS[4247] = Fluid3D([16720,16870,16450,16596],0); -ELEMENTS[4248] = Fluid3D([16450,16870,16783,16620],0); -ELEMENTS[4249] = Fluid3D([16870,16450,16596,16620],0); -ELEMENTS[4250] = Fluid3D([16720,16870,16596,17076],0); -ELEMENTS[4251] = Fluid3D([17591,17608,17863,17946],0); -ELEMENTS[4252] = Fluid3D([17666,17863,17558,17897],0); -ELEMENTS[4253] = Fluid3D([17863,17558,17897,17895],0); -ELEMENTS[4254] = Fluid3D([17666,17863,17897,17990],0); -ELEMENTS[4255] = Fluid3D([17897,17863,17895,18149],0); -ELEMENTS[4256] = Fluid3D([17558,17666,17897,17953],0); -ELEMENTS[4257] = Fluid3D([17666,17897,17953,17990],0); -ELEMENTS[4258] = Fluid3D([17897,17953,17990,18149],0); -ELEMENTS[4259] = Fluid3D([17897,17953,18149,18113],0); -ELEMENTS[4260] = Fluid3D([17897,17953,18113,17558],0); -ELEMENTS[4261] = Fluid3D([17863,17558,17895,17565],0); -ELEMENTS[4262] = Fluid3D([17591,17863,17666,17990],0); -ELEMENTS[4263] = Fluid3D([17558,17897,17895,18113],0); -ELEMENTS[4264] = Fluid3D([17273,16949,16947,17264],0); -ELEMENTS[4265] = Fluid3D([18010,17734,17920,18073],0); -ELEMENTS[4266] = Fluid3D([18010,17920,18036,18187],0); -ELEMENTS[4267] = Fluid3D([18010,17920,18187,18073],0); -ELEMENTS[4268] = Fluid3D([18036,18010,18187,18222],0); -ELEMENTS[4269] = Fluid3D([18036,18010,18222,17993],0); -ELEMENTS[4270] = Fluid3D([17920,18036,18187,18108],0); -ELEMENTS[4271] = Fluid3D([18187,18036,18222,18288],0); -ELEMENTS[4272] = Fluid3D([18036,18187,18108,18288],0); -ELEMENTS[4273] = Fluid3D([18010,18187,18222,18255],0); -ELEMENTS[4274] = Fluid3D([17920,18036,18108,17692],0); -ELEMENTS[4275] = Fluid3D([18036,18222,18288,18099],0); -ELEMENTS[4276] = Fluid3D([18187,17920,18108,18209],0); -ELEMENTS[4277] = Fluid3D([18222,18187,18288,18369],0); -ELEMENTS[4278] = Fluid3D([18187,18288,18369,18339],0); -ELEMENTS[4279] = Fluid3D([17779,17773,17499,17848],0); -ELEMENTS[4280] = Fluid3D([17324,17049,17435,17253],0); -ELEMENTS[4281] = Fluid3D([17324,17049,17253,16914],0); -ELEMENTS[4282] = Fluid3D([17435,17324,17253,17535],0); -ELEMENTS[4283] = Fluid3D([17324,17253,17535,16914],0); -ELEMENTS[4284] = Fluid3D([16450,16720,16596,16170],0); -ELEMENTS[4285] = Fluid3D([16450,16720,16170,16434],0); -ELEMENTS[4286] = Fluid3D([16596,16450,16170,16011],0); -ELEMENTS[4287] = Fluid3D([16720,16596,16170,16490],0); -ELEMENTS[4288] = Fluid3D([16450,16170,16011,15908],0); -ELEMENTS[4289] = Fluid3D([16170,16011,15908,15462],0); -ELEMENTS[4290] = Fluid3D([16596,16170,16490,16040],0); -ELEMENTS[4291] = Fluid3D([16170,16011,15462,16040],0); -ELEMENTS[4292] = Fluid3D([16170,16490,16040,15968],0); -ELEMENTS[4293] = Fluid3D([16170,16490,15968,16384],0); -ELEMENTS[4294] = Fluid3D([16170,16490,16384,16720],0); -ELEMENTS[4295] = Fluid3D([16490,16040,15968,16172],0); -ELEMENTS[4296] = Fluid3D([16490,16040,16172,16509],0); -ELEMENTS[4297] = Fluid3D([16490,16040,16509,16596],0); -ELEMENTS[4298] = Fluid3D([16596,16170,16040,16011],0); -ELEMENTS[4299] = Fluid3D([16040,15968,16172,15576],0); -ELEMENTS[4300] = Fluid3D([16172,16040,15576,15865],0); -ELEMENTS[4301] = Fluid3D([16172,16040,15865,16509],0); -ELEMENTS[4302] = Fluid3D([15968,16172,15576,15792],0); -ELEMENTS[4303] = Fluid3D([15968,16172,15792,16350],0); -ELEMENTS[4304] = Fluid3D([15968,16172,16350,16490],0); -ELEMENTS[4305] = Fluid3D([16040,15968,15576,15462],0); -ELEMENTS[4306] = Fluid3D([15576,15968,15792,15350],0); -ELEMENTS[4307] = Fluid3D([15968,15792,15350,15829],0); -ELEMENTS[4308] = Fluid3D([15968,15792,15829,16350],0); -ELEMENTS[4309] = Fluid3D([15792,15576,15350,15147],0); -ELEMENTS[4310] = Fluid3D([15792,15576,15147,15674],0); -ELEMENTS[4311] = Fluid3D([15792,15576,15674,16172],0); -ELEMENTS[4312] = Fluid3D([15576,15350,15147,14897],0); -ELEMENTS[4313] = Fluid3D([15350,15147,14897,14535],0); -ELEMENTS[4314] = Fluid3D([14897,15350,14535,14942],0); -ELEMENTS[4315] = Fluid3D([14535,14897,14942,14251],0); -ELEMENTS[4316] = Fluid3D([14535,14897,14251,14193],0); -ELEMENTS[4317] = Fluid3D([14535,14897,14193,15147],0); -ELEMENTS[4318] = Fluid3D([14897,14942,14251,14752],0); -ELEMENTS[4319] = Fluid3D([14251,14897,14752,14434],0); -ELEMENTS[4320] = Fluid3D([14251,14897,14434,14193],0); -ELEMENTS[4321] = Fluid3D([14251,14535,14193,13698],0); -ELEMENTS[4322] = Fluid3D([14897,14942,14752,15462],0); -ELEMENTS[4323] = Fluid3D([14535,14193,13698,14059],0); -ELEMENTS[4324] = Fluid3D([14535,14193,14059,15147],0); -ELEMENTS[4325] = Fluid3D([14251,14535,13698,14029],0); -ELEMENTS[4326] = Fluid3D([14535,13698,14029,14299],0); -ELEMENTS[4327] = Fluid3D([14897,14752,14434,15267],0); -ELEMENTS[4328] = Fluid3D([14434,14897,15267,14974],0); -ELEMENTS[4329] = Fluid3D([14193,13698,14059,13393],0); -ELEMENTS[4330] = Fluid3D([14059,14193,13393,14070],0); -ELEMENTS[4331] = Fluid3D([14059,14193,14070,15147],0); -ELEMENTS[4332] = Fluid3D([14193,13698,13393,13473],0); -ELEMENTS[4333] = Fluid3D([14193,13698,13473,14251],0); -ELEMENTS[4334] = Fluid3D([14897,15350,14942,15462],0); -ELEMENTS[4335] = Fluid3D([13393,14193,13473,13677],0); -ELEMENTS[4336] = Fluid3D([13393,14193,13677,14070],0); -ELEMENTS[4337] = Fluid3D([14897,14752,15267,15462],0); -ELEMENTS[4338] = Fluid3D([14897,15267,14974,15576],0); -ELEMENTS[4339] = Fluid3D([14752,14251,14434,14046],0); -ELEMENTS[4340] = Fluid3D([14251,14434,14046,13473],0); -ELEMENTS[4341] = Fluid3D([14752,14251,14046,14368],0); -ELEMENTS[4342] = Fluid3D([14251,14046,14368,13612],0); -ELEMENTS[4343] = Fluid3D([14251,14046,13612,13473],0); -ELEMENTS[4344] = Fluid3D([14752,14251,14368,14942],0); -ELEMENTS[4345] = Fluid3D([14942,14535,14251,14610],0); -ELEMENTS[4346] = Fluid3D([14251,14942,14610,14368],0); -ELEMENTS[4347] = Fluid3D([14942,14610,14368,15120],0); -ELEMENTS[4348] = Fluid3D([14942,14610,15120,15143],0); -ELEMENTS[4349] = Fluid3D([14610,14368,15120,14505],0); -ELEMENTS[4350] = Fluid3D([14610,15120,15143,14505],0); -ELEMENTS[4351] = Fluid3D([14942,14610,15143,14821],0); -ELEMENTS[4352] = Fluid3D([14942,14535,14610,14821],0); -ELEMENTS[4353] = Fluid3D([14610,14251,14368,13612],0); -ELEMENTS[4354] = Fluid3D([13698,14535,14059,14299],0); -ELEMENTS[4355] = Fluid3D([14535,14059,14299,14848],0); -ELEMENTS[4356] = Fluid3D([14059,14299,14848,14289],0); -ELEMENTS[4357] = Fluid3D([14059,14299,14289,13554],0); -ELEMENTS[4358] = Fluid3D([14059,14299,13554,13698],0); -ELEMENTS[4359] = Fluid3D([14289,14059,13554,13625],0); -ELEMENTS[4360] = Fluid3D([14848,14059,14289,14482],0); -ELEMENTS[4361] = Fluid3D([14299,14289,13554,14023],0); -ELEMENTS[4362] = Fluid3D([14299,14848,14289,14872],0); -ELEMENTS[4363] = Fluid3D([14289,14059,13625,14482],0); -ELEMENTS[4364] = Fluid3D([14848,14059,14482,15147],0); -ELEMENTS[4365] = Fluid3D([14535,14059,14848,15147],0); -ELEMENTS[4366] = Fluid3D([14059,13554,13625,13393],0); -ELEMENTS[4367] = Fluid3D([14299,14535,14848,14821],0); -ELEMENTS[4368] = Fluid3D([14434,14897,14974,14193],0); -ELEMENTS[4369] = Fluid3D([13554,14289,13625,13588],0); -ELEMENTS[4370] = Fluid3D([14289,13625,13588,14133],0); -ELEMENTS[4371] = Fluid3D([14752,14434,15267,14878],0); -ELEMENTS[4372] = Fluid3D([15267,14752,14878,15687],0); -ELEMENTS[4373] = Fluid3D([15267,14752,15687,15462],0); -ELEMENTS[4374] = Fluid3D([15267,14434,14974,14787],0); -ELEMENTS[4375] = Fluid3D([14434,14974,14787,14170],0); -ELEMENTS[4376] = Fluid3D([14434,14974,14170,14193],0); -ELEMENTS[4377] = Fluid3D([14289,13625,14133,14482],0); -ELEMENTS[4378] = Fluid3D([13554,14289,13588,14023],0); -ELEMENTS[4379] = Fluid3D([15576,15350,14897,15462],0); -ELEMENTS[4380] = Fluid3D([15576,15968,15350,15462],0); -ELEMENTS[4381] = Fluid3D([16450,16170,15908,16434],0); -ELEMENTS[4382] = Fluid3D([16720,16596,16490,17076],0); -ELEMENTS[4383] = Fluid3D([16011,15908,15462,15484],0); -ELEMENTS[4384] = Fluid3D([15908,15462,15484,15120],0); -ELEMENTS[4385] = Fluid3D([16011,15908,15484,16032],0); -ELEMENTS[4386] = Fluid3D([16011,15908,16032,16450],0); -ELEMENTS[4387] = Fluid3D([15484,16011,16032,15735],0); -ELEMENTS[4388] = Fluid3D([16011,16032,15735,16620],0); -ELEMENTS[4389] = Fluid3D([15484,16011,15735,15687],0); -ELEMENTS[4390] = Fluid3D([15908,15484,16032,15599],0); -ELEMENTS[4391] = Fluid3D([15908,15484,15599,15120],0); -ELEMENTS[4392] = Fluid3D([16032,15908,15599,16246],0); -ELEMENTS[4393] = Fluid3D([16032,15908,16246,16450],0); -ELEMENTS[4394] = Fluid3D([15484,16032,15599,15385],0); -ELEMENTS[4395] = Fluid3D([15599,16032,16246,16000],0); -ELEMENTS[4396] = Fluid3D([15484,16032,15385,15735],0); -ELEMENTS[4397] = Fluid3D([16032,15599,15385,16000],0); -ELEMENTS[4398] = Fluid3D([15462,16011,15484,15687],0); -ELEMENTS[4399] = Fluid3D([15908,15599,16246,15872],0); -ELEMENTS[4400] = Fluid3D([15908,15599,15872,15120],0); -ELEMENTS[4401] = Fluid3D([15599,16246,15872,15842],0); -ELEMENTS[4402] = Fluid3D([15872,15599,15842,15243],0); -ELEMENTS[4403] = Fluid3D([15872,15599,15243,15120],0); -ELEMENTS[4404] = Fluid3D([15599,16246,15842,16000],0); -ELEMENTS[4405] = Fluid3D([15842,15872,15243,15677],0); -ELEMENTS[4406] = Fluid3D([15842,15872,15677,16260],0); -ELEMENTS[4407] = Fluid3D([15872,15243,15677,15386],0); -ELEMENTS[4408] = Fluid3D([15842,15872,16260,16246],0); -ELEMENTS[4409] = Fluid3D([15243,15842,15677,15020],0); -ELEMENTS[4410] = Fluid3D([15872,15243,15386,15120],0); -ELEMENTS[4411] = Fluid3D([16246,15908,15872,16434],0); -ELEMENTS[4412] = Fluid3D([15599,15842,15243,15364],0); -ELEMENTS[4413] = Fluid3D([15599,15842,15364,16000],0); -ELEMENTS[4414] = Fluid3D([15243,15599,15364,14820],0); -ELEMENTS[4415] = Fluid3D([15599,15364,14820,15385],0); -ELEMENTS[4416] = Fluid3D([15842,15243,15364,15020],0); -ELEMENTS[4417] = Fluid3D([15243,15677,15386,14877],0); -ELEMENTS[4418] = Fluid3D([15243,15599,14820,15120],0); -ELEMENTS[4419] = Fluid3D([15364,15243,14820,14686],0); -ELEMENTS[4420] = Fluid3D([15364,15243,14686,15020],0); -ELEMENTS[4421] = Fluid3D([15243,14820,14686,14518],0); -ELEMENTS[4422] = Fluid3D([15243,14820,14518,15120],0); -ELEMENTS[4423] = Fluid3D([14686,15243,14518,14845],0); -ELEMENTS[4424] = Fluid3D([15243,14518,14845,14925],0); -ELEMENTS[4425] = Fluid3D([15243,14518,14925,15120],0); -ELEMENTS[4426] = Fluid3D([14518,14845,14925,14325],0); -ELEMENTS[4427] = Fluid3D([14518,14845,14325,13879],0); -ELEMENTS[4428] = Fluid3D([14518,14845,13879,14686],0); -ELEMENTS[4429] = Fluid3D([14845,14925,14325,14877],0); -ELEMENTS[4430] = Fluid3D([14845,14925,14877,15243],0); -ELEMENTS[4431] = Fluid3D([14325,14845,14877,14169],0); -ELEMENTS[4432] = Fluid3D([14877,14325,14169,14691],0); -ELEMENTS[4433] = Fluid3D([14325,14169,14691,13941],0); -ELEMENTS[4434] = Fluid3D([14325,14169,13941,13652],0); -ELEMENTS[4435] = Fluid3D([14325,14169,13652,13879],0); -ELEMENTS[4436] = Fluid3D([14325,14169,13879,14845],0); -ELEMENTS[4437] = Fluid3D([13941,14325,13652,14505],0); -ELEMENTS[4438] = Fluid3D([13941,14325,14505,14691],0); -ELEMENTS[4439] = Fluid3D([13652,14325,13879,14518],0); -ELEMENTS[4440] = Fluid3D([14845,14877,14169,14491],0); -ELEMENTS[4441] = Fluid3D([14845,14877,14491,14832],0); -ELEMENTS[4442] = Fluid3D([14325,13652,14505,14518],0); -ELEMENTS[4443] = Fluid3D([14505,14325,14518,14925],0); -ELEMENTS[4444] = Fluid3D([14518,14505,14925,15120],0); -ELEMENTS[4445] = Fluid3D([14505,14325,14925,14691],0); -ELEMENTS[4446] = Fluid3D([14925,14325,14877,14691],0); -ELEMENTS[4447] = Fluid3D([14491,14845,14832,15020],0); -ELEMENTS[4448] = Fluid3D([14877,14925,14691,15386],0); -ELEMENTS[4449] = Fluid3D([14877,14925,15386,15243],0); -ELEMENTS[4450] = Fluid3D([14925,15386,15243,15120],0); -ELEMENTS[4451] = Fluid3D([14925,14691,15386,15143],0); -ELEMENTS[4452] = Fluid3D([15386,14925,15143,15120],0); -ELEMENTS[4453] = Fluid3D([14686,15243,14845,15020],0); -ELEMENTS[4454] = Fluid3D([14820,14686,14518,14156],0); -ELEMENTS[4455] = Fluid3D([14518,14820,14156,14368],0); -ELEMENTS[4456] = Fluid3D([14820,14686,14156,14625],0); -ELEMENTS[4457] = Fluid3D([14686,14518,14156,13879],0); -ELEMENTS[4458] = Fluid3D([14686,14156,14625,14019],0); -ELEMENTS[4459] = Fluid3D([14686,14156,14019,13879],0); -ELEMENTS[4460] = Fluid3D([14156,14625,14019,13816],0); -ELEMENTS[4461] = Fluid3D([14625,14019,13816,14222],0); -ELEMENTS[4462] = Fluid3D([14625,14019,14222,14812],0); -ELEMENTS[4463] = Fluid3D([14625,14686,14019,14812],0); -ELEMENTS[4464] = Fluid3D([14156,14625,13816,14341],0); -ELEMENTS[4465] = Fluid3D([13816,14156,14341,13545],0); -ELEMENTS[4466] = Fluid3D([13816,14156,13545,13272],0); -ELEMENTS[4467] = Fluid3D([13816,14156,13272,14019],0); -ELEMENTS[4468] = Fluid3D([14625,13816,14341,14321],0); -ELEMENTS[4469] = Fluid3D([13816,14341,14321,13775],0); -ELEMENTS[4470] = Fluid3D([14156,14625,14341,14820],0); -ELEMENTS[4471] = Fluid3D([13816,14341,13775,13545],0); -ELEMENTS[4472] = Fluid3D([14625,13816,14321,14222],0); -ELEMENTS[4473] = Fluid3D([14019,13816,14222,13207],0); -ELEMENTS[4474] = Fluid3D([14222,14019,13207,14093],0); -ELEMENTS[4475] = Fluid3D([14019,13816,13207,13272],0); -ELEMENTS[4476] = Fluid3D([14019,13207,14093,13337],0); -ELEMENTS[4477] = Fluid3D([14019,13207,13337,13272],0); -ELEMENTS[4478] = Fluid3D([13816,14222,13207,13637],0); -ELEMENTS[4479] = Fluid3D([14222,13207,13637,13818],0); -ELEMENTS[4480] = Fluid3D([13816,14222,13637,14321],0); -ELEMENTS[4481] = Fluid3D([14222,13207,13818,14093],0); -ELEMENTS[4482] = Fluid3D([13207,14093,13337,13085],0); -ELEMENTS[4483] = Fluid3D([13337,13207,13085,12538],0); -ELEMENTS[4484] = Fluid3D([13337,13207,12538,13272],0); -ELEMENTS[4485] = Fluid3D([14093,13337,13085,13585],0); -ELEMENTS[4486] = Fluid3D([13337,13085,13585,12689],0); -ELEMENTS[4487] = Fluid3D([13337,13085,12689,12538],0); -ELEMENTS[4488] = Fluid3D([14093,13337,13585,14147],0); -ELEMENTS[4489] = Fluid3D([14093,13337,14147,14019],0); -ELEMENTS[4490] = Fluid3D([13585,14093,14147,14393],0); -ELEMENTS[4491] = Fluid3D([13207,14093,13085,13818],0); -ELEMENTS[4492] = Fluid3D([14222,14019,14093,14812],0); -ELEMENTS[4493] = Fluid3D([14820,14686,14625,15364],0); -ELEMENTS[4494] = Fluid3D([16596,16450,16011,16620],0); -ELEMENTS[4495] = Fluid3D([16040,16170,15968,15462],0); -ELEMENTS[4496] = Fluid3D([15576,16172,15865,15674],0); -ELEMENTS[4497] = Fluid3D([15599,15484,15385,14820],0); -ELEMENTS[4498] = Fluid3D([17128,17207,17334,16890],0); -ELEMENTS[4499] = Fluid3D([17128,17207,16890,16807],0); -ELEMENTS[4500] = Fluid3D([17334,17128,16890,17033],0); -ELEMENTS[4501] = Fluid3D([17128,16890,17033,16674],0); -ELEMENTS[4502] = Fluid3D([17207,16890,16807,16812],0); -ELEMENTS[4503] = Fluid3D([17207,16890,16812,17139],0); -ELEMENTS[4504] = Fluid3D([17207,16890,17139,17334],0); -ELEMENTS[4505] = Fluid3D([16890,16807,16812,16410],0); -ELEMENTS[4506] = Fluid3D([16807,16812,16410,16454],0); -ELEMENTS[4507] = Fluid3D([16807,16812,16454,17171],0); -ELEMENTS[4508] = Fluid3D([16812,16890,16410,16625],0); -ELEMENTS[4509] = Fluid3D([16812,16890,16625,17139],0); -ELEMENTS[4510] = Fluid3D([16890,16807,16410,16674],0); -ELEMENTS[4511] = Fluid3D([16890,16410,16625,16474],0); -ELEMENTS[4512] = Fluid3D([16625,16890,16474,16913],0); -ELEMENTS[4513] = Fluid3D([16625,16890,16913,17139],0); -ELEMENTS[4514] = Fluid3D([16410,16625,16474,16077],0); -ELEMENTS[4515] = Fluid3D([16410,16625,16077,16275],0); -ELEMENTS[4516] = Fluid3D([16410,16625,16275,16812],0); -ELEMENTS[4517] = Fluid3D([16625,16474,16077,16519],0); -ELEMENTS[4518] = Fluid3D([16625,16474,16519,16913],0); -ELEMENTS[4519] = Fluid3D([16890,16410,16474,16674],0); -ELEMENTS[4520] = Fluid3D([16474,16077,16519,15996],0); -ELEMENTS[4521] = Fluid3D([16077,16519,15996,15813],0); -ELEMENTS[4522] = Fluid3D([16474,16077,15996,15984],0); -ELEMENTS[4523] = Fluid3D([16474,16077,15984,16410],0); -ELEMENTS[4524] = Fluid3D([16519,15996,15813,16096],0); -ELEMENTS[4525] = Fluid3D([16519,15996,16096,16468],0); -ELEMENTS[4526] = Fluid3D([16519,15996,16468,16474],0); -ELEMENTS[4527] = Fluid3D([15813,16519,16096,16309],0); -ELEMENTS[4528] = Fluid3D([16519,16096,16309,16500],0); -ELEMENTS[4529] = Fluid3D([16519,16096,16500,16468],0); -ELEMENTS[4530] = Fluid3D([15813,16519,16309,16209],0); -ELEMENTS[4531] = Fluid3D([16309,15813,16209,15744],0); -ELEMENTS[4532] = Fluid3D([15813,16519,16209,16077],0); -ELEMENTS[4533] = Fluid3D([16309,15813,15744,15658],0); -ELEMENTS[4534] = Fluid3D([16309,15813,15658,16096],0); -ELEMENTS[4535] = Fluid3D([15744,16309,15658,15913],0); -ELEMENTS[4536] = Fluid3D([16309,15658,15913,15927],0); -ELEMENTS[4537] = Fluid3D([16309,15658,15927,16096],0); -ELEMENTS[4538] = Fluid3D([15744,16309,15913,16277],0); -ELEMENTS[4539] = Fluid3D([15744,16309,16277,16209],0); -ELEMENTS[4540] = Fluid3D([16309,15913,16277,16736],0); -ELEMENTS[4541] = Fluid3D([15813,15744,15658,15196],0); -ELEMENTS[4542] = Fluid3D([15744,15658,15196,15182],0); -ELEMENTS[4543] = Fluid3D([15658,15196,15182,14854],0); -ELEMENTS[4544] = Fluid3D([15658,15196,14854,15407],0); -ELEMENTS[4545] = Fluid3D([15658,15196,15407,15813],0); -ELEMENTS[4546] = Fluid3D([15813,15744,15196,15559],0); -ELEMENTS[4547] = Fluid3D([15744,15658,15182,15913],0); -ELEMENTS[4548] = Fluid3D([15813,15744,15559,16209],0); -ELEMENTS[4549] = Fluid3D([15744,15196,15559,15189],0); -ELEMENTS[4550] = Fluid3D([15744,15196,15189,15182],0); -ELEMENTS[4551] = Fluid3D([15196,15559,15189,14861],0); -ELEMENTS[4552] = Fluid3D([15189,15196,14861,14579],0); -ELEMENTS[4553] = Fluid3D([15189,15196,14579,15182],0); -ELEMENTS[4554] = Fluid3D([15196,15559,14861,15247],0); -ELEMENTS[4555] = Fluid3D([15559,14861,15247,15217],0); -ELEMENTS[4556] = Fluid3D([15559,14861,15217,15305],0); -ELEMENTS[4557] = Fluid3D([15196,15559,15247,15813],0); -ELEMENTS[4558] = Fluid3D([15559,14861,15305,15189],0); -ELEMENTS[4559] = Fluid3D([15559,15744,15189,15808],0); -ELEMENTS[4560] = Fluid3D([15744,15189,15808,15603],0); -ELEMENTS[4561] = Fluid3D([15189,15808,15603,15051],0); -ELEMENTS[4562] = Fluid3D([15189,15808,15051,15305],0); -ELEMENTS[4563] = Fluid3D([15744,15189,15603,15182],0); -ELEMENTS[4564] = Fluid3D([15559,15744,15808,16209],0); -ELEMENTS[4565] = Fluid3D([17334,17128,17033,17463],0); -ELEMENTS[4566] = Fluid3D([17128,16890,16674,16807],0); -ELEMENTS[4567] = Fluid3D([16890,17033,16674,16474],0); -ELEMENTS[4568] = Fluid3D([16890,16474,16913,17033],0); -ELEMENTS[4569] = Fluid3D([17128,17207,16807,17247],0); -ELEMENTS[4570] = Fluid3D([16807,17207,16812,17171],0); -ELEMENTS[4571] = Fluid3D([16890,17334,17033,16913],0); -ELEMENTS[4572] = Fluid3D([17033,17128,16674,17138],0); -ELEMENTS[4573] = Fluid3D([15908,16170,15462,15778],0); -ELEMENTS[4574] = Fluid3D([15908,16170,15778,16434],0); -ELEMENTS[4575] = Fluid3D([16170,15462,15778,15968],0); -ELEMENTS[4576] = Fluid3D([15462,15908,15778,15120],0); -ELEMENTS[4577] = Fluid3D([15792,15350,15829,15340],0); -ELEMENTS[4578] = Fluid3D([15792,15350,15340,15147],0); -ELEMENTS[4579] = Fluid3D([15350,15829,15340,14821],0); -ELEMENTS[4580] = Fluid3D([15829,15792,15340,15960],0); -ELEMENTS[4581] = Fluid3D([15829,15792,15960,16350],0); -ELEMENTS[4582] = Fluid3D([15792,15340,15960,15558],0); -ELEMENTS[4583] = Fluid3D([15792,15340,15558,15147],0); -ELEMENTS[4584] = Fluid3D([15960,15792,15558,16164],0); -ELEMENTS[4585] = Fluid3D([15960,15792,16164,16350],0); -ELEMENTS[4586] = Fluid3D([15792,15558,16164,15674],0); -ELEMENTS[4587] = Fluid3D([15340,15960,15558,15458],0); -ELEMENTS[4588] = Fluid3D([15340,15960,15458,15624],0); -ELEMENTS[4589] = Fluid3D([15960,15458,15624,16018],0); -ELEMENTS[4590] = Fluid3D([15960,15558,15458,15911],0); -ELEMENTS[4591] = Fluid3D([15960,15558,15911,16164],0); -ELEMENTS[4592] = Fluid3D([15458,15624,16018,15446],0); -ELEMENTS[4593] = Fluid3D([15458,15624,15446,14961],0); -ELEMENTS[4594] = Fluid3D([15624,15446,14961,15241],0); -ELEMENTS[4595] = Fluid3D([15624,15446,15241,15888],0); -ELEMENTS[4596] = Fluid3D([15624,15446,15888,16018],0); -ELEMENTS[4597] = Fluid3D([15458,15624,14961,15340],0); -ELEMENTS[4598] = Fluid3D([15446,14961,15241,14790],0); -ELEMENTS[4599] = Fluid3D([15446,14961,14790,14904],0); -ELEMENTS[4600] = Fluid3D([15241,15446,14790,15384],0); -ELEMENTS[4601] = Fluid3D([14961,15241,14790,14872],0); -ELEMENTS[4602] = Fluid3D([14961,15241,14872,15624],0); -ELEMENTS[4603] = Fluid3D([15241,15446,15384,15888],0); -ELEMENTS[4604] = Fluid3D([15446,14961,14904,15458],0); -ELEMENTS[4605] = Fluid3D([15960,15458,16018,15911],0); -ELEMENTS[4606] = Fluid3D([15558,15340,15458,14848],0); -ELEMENTS[4607] = Fluid3D([15558,15340,14848,15147],0); -ELEMENTS[4608] = Fluid3D([15340,14848,15147,15350],0); -ELEMENTS[4609] = Fluid3D([15340,14848,15350,14821],0); -ELEMENTS[4610] = Fluid3D([14790,15446,14904,15155],0); -ELEMENTS[4611] = Fluid3D([14790,15446,15155,15384],0); -ELEMENTS[4612] = Fluid3D([14904,14790,15155,14383],0); -ELEMENTS[4613] = Fluid3D([14790,15155,14383,14673],0); -ELEMENTS[4614] = Fluid3D([14790,15155,14673,15384],0); -ELEMENTS[4615] = Fluid3D([15446,14904,15155,15514],0); -ELEMENTS[4616] = Fluid3D([15446,14904,15514,15458],0); -ELEMENTS[4617] = Fluid3D([14904,15155,15514,14957],0); -ELEMENTS[4618] = Fluid3D([14904,15155,14957,14383],0); -ELEMENTS[4619] = Fluid3D([14383,14790,14673,14015],0); -ELEMENTS[4620] = Fluid3D([14383,14790,14015,14138],0); -ELEMENTS[4621] = Fluid3D([14673,14383,14015,13930],0); -ELEMENTS[4622] = Fluid3D([14673,14383,13930,14645],0); -ELEMENTS[4623] = Fluid3D([14383,14790,14138,14904],0); -ELEMENTS[4624] = Fluid3D([15155,15514,14957,15522],0); -ELEMENTS[4625] = Fluid3D([15155,15514,15522,15826],0); -ELEMENTS[4626] = Fluid3D([15514,14957,15522,15531],0); -ELEMENTS[4627] = Fluid3D([15514,14957,15531,15178],0); -ELEMENTS[4628] = Fluid3D([15155,15514,15826,15446],0); -ELEMENTS[4629] = Fluid3D([15514,14957,15178,14904],0); -ELEMENTS[4630] = Fluid3D([14673,14383,14645,15155],0); -ELEMENTS[4631] = Fluid3D([14383,14015,13930,13536],0); -ELEMENTS[4632] = Fluid3D([14015,13930,13536,12994],0); -ELEMENTS[4633] = Fluid3D([13930,13536,12994,13095],0); -ELEMENTS[4634] = Fluid3D([14015,13930,12994,13841],0); -ELEMENTS[4635] = Fluid3D([14015,13930,13841,14673],0); -ELEMENTS[4636] = Fluid3D([13930,13536,13095,13811],0); -ELEMENTS[4637] = Fluid3D([13930,13536,13811,14383],0); -ELEMENTS[4638] = Fluid3D([14383,14015,13536,14138],0); -ELEMENTS[4639] = Fluid3D([13536,13095,13811,13021],0); -ELEMENTS[4640] = Fluid3D([13536,13095,13021,12592],0); -ELEMENTS[4641] = Fluid3D([13536,13095,12592,12994],0); -ELEMENTS[4642] = Fluid3D([13095,13021,12592,12263],0); -ELEMENTS[4643] = Fluid3D([13021,12592,12263,11966],0); -ELEMENTS[4644] = Fluid3D([13021,12592,11966,12932],0); -ELEMENTS[4645] = Fluid3D([13021,12592,12932,13536],0); -ELEMENTS[4646] = Fluid3D([13095,13021,12263,13119],0); -ELEMENTS[4647] = Fluid3D([13021,12263,13119,12426],0); -ELEMENTS[4648] = Fluid3D([13021,12263,12426,11966],0); -ELEMENTS[4649] = Fluid3D([13095,13021,13119,13811],0); -ELEMENTS[4650] = Fluid3D([14790,14673,14015,14618],0); -ELEMENTS[4651] = Fluid3D([14015,14790,14618,14023],0); -ELEMENTS[4652] = Fluid3D([14790,14673,14618,15384],0); -ELEMENTS[4653] = Fluid3D([14673,14015,14618,13841],0); -ELEMENTS[4654] = Fluid3D([15558,15458,15911,15394],0); -ELEMENTS[4655] = Fluid3D([15558,15458,15394,14910],0); -ELEMENTS[4656] = Fluid3D([15458,15394,14910,14904],0); -ELEMENTS[4657] = Fluid3D([15458,15911,15394,15514],0); -ELEMENTS[4658] = Fluid3D([15911,15558,15394,15828],0); -ELEMENTS[4659] = Fluid3D([15911,15558,15828,16164],0); -ELEMENTS[4660] = Fluid3D([15558,15394,15828,15188],0); -ELEMENTS[4661] = Fluid3D([15394,15828,15188,15344],0); -ELEMENTS[4662] = Fluid3D([15558,15394,15188,14910],0); -ELEMENTS[4663] = Fluid3D([15394,15911,15828,15947],0); -ELEMENTS[4664] = Fluid3D([15911,15828,15947,16373],0); -ELEMENTS[4665] = Fluid3D([15911,15828,16373,16164],0); -ELEMENTS[4666] = Fluid3D([15394,15911,15947,15514],0); -ELEMENTS[4667] = Fluid3D([15394,15828,15344,15947],0); -ELEMENTS[4668] = Fluid3D([15558,15458,14910,14848],0); -ELEMENTS[4669] = Fluid3D([14957,15155,15522,14645],0); -ELEMENTS[4670] = Fluid3D([12592,13095,12263,12290],0); -ELEMENTS[4671] = Fluid3D([12592,13095,12290,12994],0); -ELEMENTS[4672] = Fluid3D([13095,12263,12290,12515],0); -ELEMENTS[4673] = Fluid3D([12290,13095,12515,13137],0); -ELEMENTS[4674] = Fluid3D([12515,12290,13137,12112],0); -ELEMENTS[4675] = Fluid3D([12515,12290,12112,11541],0); -ELEMENTS[4676] = Fluid3D([12515,12290,11541,12263],0); -ELEMENTS[4677] = Fluid3D([13095,12263,12515,13119],0); -ELEMENTS[4678] = Fluid3D([12290,13095,13137,12994],0); -ELEMENTS[4679] = Fluid3D([12263,12592,12290,11630],0); -ELEMENTS[4680] = Fluid3D([12592,12290,11630,12325],0); -ELEMENTS[4681] = Fluid3D([12263,12592,11630,11966],0); -ELEMENTS[4682] = Fluid3D([12290,12263,11630,11541],0); -ELEMENTS[4683] = Fluid3D([12290,11630,12325,11320],0); -ELEMENTS[4684] = Fluid3D([12325,12290,11320,12255],0); -ELEMENTS[4685] = Fluid3D([12325,12290,12255,12994],0); -ELEMENTS[4686] = Fluid3D([12290,11630,11320,11541],0); -ELEMENTS[4687] = Fluid3D([11630,12325,11320,11121],0); -ELEMENTS[4688] = Fluid3D([12325,11320,11121,11489],0); -ELEMENTS[4689] = Fluid3D([12325,11320,11489,12255],0); -ELEMENTS[4690] = Fluid3D([11320,11630,11121,10783],0); -ELEMENTS[4691] = Fluid3D([11320,11630,10783,11541],0); -ELEMENTS[4692] = Fluid3D([11630,11121,10783,10887],0); -ELEMENTS[4693] = Fluid3D([11630,11121,10887,11769],0); -ELEMENTS[4694] = Fluid3D([11630,11121,11769,12325],0); -ELEMENTS[4695] = Fluid3D([11121,10783,10887,10114],0); -ELEMENTS[4696] = Fluid3D([11121,10783,10114,10458],0); -ELEMENTS[4697] = Fluid3D([11121,10783,10458,11320],0); -ELEMENTS[4698] = Fluid3D([10783,10887,10114,9972],0); -ELEMENTS[4699] = Fluid3D([10887,10114,9972,10263],0); -ELEMENTS[4700] = Fluid3D([10887,10114,10263,10711],0); -ELEMENTS[4701] = Fluid3D([10887,10114,10711,11121],0); -ELEMENTS[4702] = Fluid3D([10783,10887,9972,10889],0); -ELEMENTS[4703] = Fluid3D([10887,9972,10889,10558],0); -ELEMENTS[4704] = Fluid3D([10887,9972,10558,10263],0); -ELEMENTS[4705] = Fluid3D([9972,10783,10889,10121],0); -ELEMENTS[4706] = Fluid3D([10783,10887,10889,11630],0); -ELEMENTS[4707] = Fluid3D([10783,10889,10121,11541],0); -ELEMENTS[4708] = Fluid3D([9972,10783,10121,9633],0); -ELEMENTS[4709] = Fluid3D([10121,9972,9633,9201],0); -ELEMENTS[4710] = Fluid3D([10121,9972,9201,9904],0); -ELEMENTS[4711] = Fluid3D([10121,9972,9904,10889],0); -ELEMENTS[4712] = Fluid3D([10783,10121,9633,10313],0); -ELEMENTS[4713] = Fluid3D([10783,10121,10313,11541],0); -ELEMENTS[4714] = Fluid3D([9633,10783,10313,10458],0); -ELEMENTS[4715] = Fluid3D([9972,10783,9633,10114],0); -ELEMENTS[4716] = Fluid3D([12592,12290,12325,12994],0); -ELEMENTS[4717] = Fluid3D([13095,12515,13137,13435],0); -ELEMENTS[4718] = Fluid3D([12515,13137,13435,13316],0); -ELEMENTS[4719] = Fluid3D([13435,12515,13316,12888],0); -ELEMENTS[4720] = Fluid3D([13095,12515,13435,13119],0); -ELEMENTS[4721] = Fluid3D([13137,13095,13435,13930],0); -ELEMENTS[4722] = Fluid3D([12290,13137,12112,12255],0); -ELEMENTS[4723] = Fluid3D([13536,14015,12994,13051],0); -ELEMENTS[4724] = Fluid3D([14015,12994,13051,13295],0); -ELEMENTS[4725] = Fluid3D([12994,13536,13051,12592],0); -ELEMENTS[4726] = Fluid3D([13536,14015,13051,14138],0); -ELEMENTS[4727] = Fluid3D([12994,13051,13295,12325],0); -ELEMENTS[4728] = Fluid3D([14015,12994,13295,13841],0); -ELEMENTS[4729] = Fluid3D([13051,14015,13295,14023],0); -ELEMENTS[4730] = Fluid3D([15340,15960,15624,15829],0); -ELEMENTS[4731] = Fluid3D([15624,15960,16018,16241],0); -ELEMENTS[4732] = Fluid3D([15624,15960,16241,15829],0); -ELEMENTS[4733] = Fluid3D([16018,15624,16241,15888],0); -ELEMENTS[4734] = Fluid3D([15960,16018,16241,16464],0); -ELEMENTS[4735] = Fluid3D([16241,15960,16464,16350],0); -ELEMENTS[4736] = Fluid3D([15960,16018,16464,15911],0); -ELEMENTS[4737] = Fluid3D([16018,16241,16464,16517],0); -ELEMENTS[4738] = Fluid3D([16464,16018,16517,16443],0); -ELEMENTS[4739] = Fluid3D([16018,16517,16443,16540],0); -ELEMENTS[4740] = Fluid3D([16018,16241,16517,15888],0); -ELEMENTS[4741] = Fluid3D([16464,16018,16443,15911],0); -ELEMENTS[4742] = Fluid3D([16241,16464,16517,16770],0); -ELEMENTS[4743] = Fluid3D([16241,16464,16770,16350],0); -ELEMENTS[4744] = Fluid3D([16464,16517,16770,17124],0); -ELEMENTS[4745] = Fluid3D([16517,16241,16770,16899],0); -ELEMENTS[4746] = Fluid3D([16517,16464,16443,17124],0); -ELEMENTS[4747] = Fluid3D([16018,15458,15446,15514],0); -ELEMENTS[4748] = Fluid3D([12263,13119,12426,12049],0); -ELEMENTS[4749] = Fluid3D([13811,13536,13021,13810],0); -ELEMENTS[4750] = Fluid3D([13811,13536,13810,14383],0); -ELEMENTS[4751] = Fluid3D([13536,13021,13810,12932],0); -ELEMENTS[4752] = Fluid3D([13021,13811,13810,13583],0); -ELEMENTS[4753] = Fluid3D([13021,13811,13583,13119],0); -ELEMENTS[4754] = Fluid3D([13810,13021,13583,13126],0); -ELEMENTS[4755] = Fluid3D([13021,13583,13126,12426],0); -ELEMENTS[4756] = Fluid3D([13810,13021,13126,12932],0); -ELEMENTS[4757] = Fluid3D([13583,13810,13126,14107],0); -ELEMENTS[4758] = Fluid3D([13810,13126,14107,14133],0); -ELEMENTS[4759] = Fluid3D([13126,13583,14107,13171],0); -ELEMENTS[4760] = Fluid3D([13126,13583,13171,12426],0); -ELEMENTS[4761] = Fluid3D([13583,13810,14107,14400],0); -ELEMENTS[4762] = Fluid3D([13810,14107,14400,14534],0); -ELEMENTS[4763] = Fluid3D([13583,13810,14400,13811],0); -ELEMENTS[4764] = Fluid3D([14107,14400,14534,14783],0); -ELEMENTS[4765] = Fluid3D([13810,14107,14534,14133],0); -ELEMENTS[4766] = Fluid3D([14534,13810,14133,14904],0); -ELEMENTS[4767] = Fluid3D([14107,14534,14133,14488],0); -ELEMENTS[4768] = Fluid3D([14534,14133,14488,14910],0); -ELEMENTS[4769] = Fluid3D([14107,14534,14488,14824],0); -ELEMENTS[4770] = Fluid3D([14534,14488,14824,15178],0); -ELEMENTS[4771] = Fluid3D([14824,14534,15178,14957],0); -ELEMENTS[4772] = Fluid3D([14534,15178,14957,14904],0); -ELEMENTS[4773] = Fluid3D([14534,15178,14904,14910],0); -ELEMENTS[4774] = Fluid3D([14534,14488,15178,14910],0); -ELEMENTS[4775] = Fluid3D([14107,14534,14824,14783],0); -ELEMENTS[4776] = Fluid3D([14824,14107,14783,14088],0); -ELEMENTS[4777] = Fluid3D([14824,14107,14088,14488],0); -ELEMENTS[4778] = Fluid3D([14783,14824,14088,14923],0); -ELEMENTS[4779] = Fluid3D([14783,14824,14923,15513],0); -ELEMENTS[4780] = Fluid3D([14824,14088,14923,14488],0); -ELEMENTS[4781] = Fluid3D([14783,14824,15513,15531],0); -ELEMENTS[4782] = Fluid3D([14824,14923,15513,15344],0); -ELEMENTS[4783] = Fluid3D([14923,14824,14488,15344],0); -ELEMENTS[4784] = Fluid3D([14107,14783,14088,13934],0); -ELEMENTS[4785] = Fluid3D([14088,14107,13934,13171],0); -ELEMENTS[4786] = Fluid3D([14088,14107,13171,13335],0); -ELEMENTS[4787] = Fluid3D([14107,13583,14400,13934],0); -ELEMENTS[4788] = Fluid3D([13583,14400,13934,13806],0); -ELEMENTS[4789] = Fluid3D([14107,13583,13934,13171],0); -ELEMENTS[4790] = Fluid3D([13583,13934,13171,13025],0); -ELEMENTS[4791] = Fluid3D([13583,13934,13025,13806],0); -ELEMENTS[4792] = Fluid3D([13171,13583,13025,12426],0); -ELEMENTS[4793] = Fluid3D([13583,13025,12426,13119],0); -ELEMENTS[4794] = Fluid3D([13025,12426,13119,12049],0); -ELEMENTS[4795] = Fluid3D([13025,12426,12049,12202],0); -ELEMENTS[4796] = Fluid3D([13025,12426,12202,13171],0); -ELEMENTS[4797] = Fluid3D([12426,12049,12202,11170],0); -ELEMENTS[4798] = Fluid3D([13583,13025,13119,13806],0); -ELEMENTS[4799] = Fluid3D([14400,14107,13934,14783],0); -ELEMENTS[4800] = Fluid3D([14400,13810,14534,14957],0); -ELEMENTS[4801] = Fluid3D([14534,14400,14957,14783],0); -ELEMENTS[4802] = Fluid3D([14961,14790,14904,14138],0); -ELEMENTS[4803] = Fluid3D([17344,17605,17438,17739],0); -ELEMENTS[4804] = Fluid3D([17438,17344,17739,17448],0); -ELEMENTS[4805] = Fluid3D([17344,17739,17448,17535],0); -ELEMENTS[4806] = Fluid3D([17448,17344,17535,17253],0); -ELEMENTS[4807] = Fluid3D([17739,17448,17535,17737],0); -ELEMENTS[4808] = Fluid3D([17739,17448,17737,17415],0); -ELEMENTS[4809] = Fluid3D([17448,17535,17737,17253],0); -ELEMENTS[4810] = Fluid3D([17344,17739,17535,17605],0); -ELEMENTS[4811] = Fluid3D([17535,17739,17737,17920],0); -ELEMENTS[4812] = Fluid3D([17739,17438,17448,17415],0); -ELEMENTS[4813] = Fluid3D([17605,17438,17739,17758],0); -ELEMENTS[4814] = Fluid3D([16147,16661,16546,16822],0); -ELEMENTS[4815] = Fluid3D([17087,16848,17017,17350],0); -ELEMENTS[4816] = Fluid3D([16669,17017,16866,17228],0); -ELEMENTS[4817] = Fluid3D([17017,16866,17228,17338],0); -ELEMENTS[4818] = Fluid3D([12640,13394,12956,12545],0); -ELEMENTS[4819] = Fluid3D([12956,12640,12545,12018],0); -ELEMENTS[4820] = Fluid3D([12640,12545,12018,11666],0); -ELEMENTS[4821] = Fluid3D([12640,13394,12545,12772],0); -ELEMENTS[4822] = Fluid3D([13394,12545,12772,13186],0); -ELEMENTS[4823] = Fluid3D([12545,12018,11666,11612],0); -ELEMENTS[4824] = Fluid3D([12545,12018,11612,12350],0); -ELEMENTS[4825] = Fluid3D([12545,12018,12350,12956],0); -ELEMENTS[4826] = Fluid3D([12018,11612,12350,11399],0); -ELEMENTS[4827] = Fluid3D([13394,12545,13186,13266],0); -ELEMENTS[4828] = Fluid3D([13394,12545,13266,12956],0); -ELEMENTS[4829] = Fluid3D([12350,12018,11399,12214],0); -ELEMENTS[4830] = Fluid3D([12350,12018,12214,12956],0); -ELEMENTS[4831] = Fluid3D([12018,11399,12214,11434],0); -ELEMENTS[4832] = Fluid3D([11399,12214,11434,11366],0); -ELEMENTS[4833] = Fluid3D([11399,12214,11366,11807],0); -ELEMENTS[4834] = Fluid3D([11399,12214,11807,12350],0); -ELEMENTS[4835] = Fluid3D([12018,11612,11399,11024],0); -ELEMENTS[4836] = Fluid3D([12018,11612,11024,11666],0); -ELEMENTS[4837] = Fluid3D([11612,11399,11024,10656],0); -ELEMENTS[4838] = Fluid3D([12018,11399,11434,11024],0); -ELEMENTS[4839] = Fluid3D([11399,11024,10656,10425],0); -ELEMENTS[4840] = Fluid3D([11399,11024,10425,11434],0); -ELEMENTS[4841] = Fluid3D([11024,10656,10425,9999],0); -ELEMENTS[4842] = Fluid3D([10656,10425,9999,9696],0); -ELEMENTS[4843] = Fluid3D([11024,10656,9999,10753],0); -ELEMENTS[4844] = Fluid3D([10656,10425,9696,10540],0); -ELEMENTS[4845] = Fluid3D([10656,10425,10540,11399],0); -ELEMENTS[4846] = Fluid3D([11024,10656,10753,11612],0); -ELEMENTS[4847] = Fluid3D([11612,11399,10656,11441],0); -ELEMENTS[4848] = Fluid3D([11399,10656,11441,10540],0); -ELEMENTS[4849] = Fluid3D([11612,11399,11441,12350],0); -ELEMENTS[4850] = Fluid3D([12640,13394,12772,13358],0); -ELEMENTS[4851] = Fluid3D([12545,12772,13186,12271],0); -ELEMENTS[4852] = Fluid3D([12545,12772,12271,11666],0); -ELEMENTS[4853] = Fluid3D([13186,12545,12271,12581],0); -ELEMENTS[4854] = Fluid3D([13186,12545,12581,13266],0); -ELEMENTS[4855] = Fluid3D([12271,13186,12581,12828],0); -ELEMENTS[4856] = Fluid3D([12581,12271,12828,11962],0); -ELEMENTS[4857] = Fluid3D([12581,12271,11962,11612],0); -ELEMENTS[4858] = Fluid3D([12271,13186,12828,12957],0); -ELEMENTS[4859] = Fluid3D([12271,13186,12957,12772],0); -ELEMENTS[4860] = Fluid3D([13186,12828,12957,13670],0); -ELEMENTS[4861] = Fluid3D([12828,12957,13670,13123],0); -ELEMENTS[4862] = Fluid3D([12828,12957,13123,12222],0); -ELEMENTS[4863] = Fluid3D([12828,12957,12222,12271],0); -ELEMENTS[4864] = Fluid3D([12957,13186,13670,13709],0); -ELEMENTS[4865] = Fluid3D([12957,13186,13709,12772],0); -ELEMENTS[4866] = Fluid3D([13186,13670,13709,14476],0); -ELEMENTS[4867] = Fluid3D([13186,12828,13670,13699],0); -ELEMENTS[4868] = Fluid3D([13186,12828,13699,12581],0); -ELEMENTS[4869] = Fluid3D([12828,13670,13699,13518],0); -ELEMENTS[4870] = Fluid3D([13670,13699,13518,14262],0); -ELEMENTS[4871] = Fluid3D([13518,13670,14262,13123],0); -ELEMENTS[4872] = Fluid3D([12828,13670,13518,13123],0); -ELEMENTS[4873] = Fluid3D([13670,13186,13699,14476],0); -ELEMENTS[4874] = Fluid3D([12828,12581,11962,12626],0); -ELEMENTS[4875] = Fluid3D([12828,12581,12626,13699],0); -ELEMENTS[4876] = Fluid3D([12581,11962,12626,11860],0); -ELEMENTS[4877] = Fluid3D([12581,11962,11860,11612],0); -ELEMENTS[4878] = Fluid3D([11962,12626,11860,11549],0); -ELEMENTS[4879] = Fluid3D([11962,12828,12626,12330],0); -ELEMENTS[4880] = Fluid3D([12828,12626,12330,13518],0); -ELEMENTS[4881] = Fluid3D([11962,12828,12330,12222],0); -ELEMENTS[4882] = Fluid3D([12626,11962,12330,11549],0); -ELEMENTS[4883] = Fluid3D([12626,12581,11860,12756],0); -ELEMENTS[4884] = Fluid3D([12581,11860,12756,12350],0); -ELEMENTS[4885] = Fluid3D([12626,12581,12756,13699],0); -ELEMENTS[4886] = Fluid3D([11860,12626,12756,12354],0); -ELEMENTS[4887] = Fluid3D([11860,12626,12354,11549],0); -ELEMENTS[4888] = Fluid3D([12756,11860,12354,12123],0); -ELEMENTS[4889] = Fluid3D([12626,12756,12354,13276],0); -ELEMENTS[4890] = Fluid3D([12626,12756,13276,13699],0); -ELEMENTS[4891] = Fluid3D([11860,12354,12123,11395],0); -ELEMENTS[4892] = Fluid3D([11860,12354,11395,11549],0); -ELEMENTS[4893] = Fluid3D([12354,12123,11395,12658],0); -ELEMENTS[4894] = Fluid3D([12354,12123,12658,12756],0); -ELEMENTS[4895] = Fluid3D([12756,11860,12123,12201],0); -ELEMENTS[4896] = Fluid3D([12756,11860,12201,12350],0); -ELEMENTS[4897] = Fluid3D([11860,12123,12201,11441],0); -ELEMENTS[4898] = Fluid3D([12201,11860,11441,12350],0); -ELEMENTS[4899] = Fluid3D([11441,12201,12350,11807],0); -ELEMENTS[4900] = Fluid3D([12201,12350,11807,12882],0); -ELEMENTS[4901] = Fluid3D([12201,12350,12882,12756],0); -ELEMENTS[4902] = Fluid3D([12123,12756,12201,13064],0); -ELEMENTS[4903] = Fluid3D([12756,12201,13064,12882],0); -ELEMENTS[4904] = Fluid3D([12201,13064,12882,11807],0); -ELEMENTS[4905] = Fluid3D([12123,12756,13064,12880],0); -ELEMENTS[4906] = Fluid3D([13064,12123,12880,12218],0); -ELEMENTS[4907] = Fluid3D([12880,13064,12218,13210],0); -ELEMENTS[4908] = Fluid3D([12880,13064,13210,13947],0); -ELEMENTS[4909] = Fluid3D([12123,12880,12218,12517],0); -ELEMENTS[4910] = Fluid3D([12218,12880,13210,13244],0); -ELEMENTS[4911] = Fluid3D([13064,12218,13210,12742],0); -ELEMENTS[4912] = Fluid3D([13210,13064,12742,13597],0); -ELEMENTS[4913] = Fluid3D([13210,13064,13597,13947],0); -ELEMENTS[4914] = Fluid3D([13064,12218,12742,11807],0); -ELEMENTS[4915] = Fluid3D([13064,12742,13597,12882],0); -ELEMENTS[4916] = Fluid3D([13064,12742,12882,11807],0); -ELEMENTS[4917] = Fluid3D([12742,13597,12882,13134],0); -ELEMENTS[4918] = Fluid3D([12882,12742,13134,11807],0); -ELEMENTS[4919] = Fluid3D([13597,13064,12882,13476],0); -ELEMENTS[4920] = Fluid3D([13064,12882,13476,12756],0); -ELEMENTS[4921] = Fluid3D([13597,12882,13134,13748],0); -ELEMENTS[4922] = Fluid3D([12882,13597,13476,13748],0); -ELEMENTS[4923] = Fluid3D([13476,12882,13748,13266],0); -ELEMENTS[4924] = Fluid3D([13748,13476,13266,14060],0); -ELEMENTS[4925] = Fluid3D([13476,13266,14060,13699],0); -ELEMENTS[4926] = Fluid3D([13748,13476,14060,14234],0); -ELEMENTS[4927] = Fluid3D([13476,14060,14234,13949],0); -ELEMENTS[4928] = Fluid3D([14060,14234,13949,14716],0); -ELEMENTS[4929] = Fluid3D([14060,14234,14716,14743],0); -ELEMENTS[4930] = Fluid3D([14716,14060,14743,14758],0); -ELEMENTS[4931] = Fluid3D([14716,14060,14758,14476],0); -ELEMENTS[4932] = Fluid3D([14060,14234,14743,13748],0); -ELEMENTS[4933] = Fluid3D([13949,14060,14716,14476],0); -ELEMENTS[4934] = Fluid3D([14060,14743,14758,14240],0); -ELEMENTS[4935] = Fluid3D([13476,14060,13949,13699],0); -ELEMENTS[4936] = Fluid3D([14060,14743,14240,13748],0); -ELEMENTS[4937] = Fluid3D([14240,14060,13748,13682],0); -ELEMENTS[4938] = Fluid3D([13748,14240,13682,13613],0); -ELEMENTS[4939] = Fluid3D([13748,14240,13613,14120],0); -ELEMENTS[4940] = Fluid3D([13748,14240,14120,14743],0); -ELEMENTS[4941] = Fluid3D([14240,13682,13613,14223],0); -ELEMENTS[4942] = Fluid3D([14240,13613,14120,14406],0); -ELEMENTS[4943] = Fluid3D([14234,13476,13949,13741],0); -ELEMENTS[4944] = Fluid3D([13613,13748,14120,13134],0); -ELEMENTS[4945] = Fluid3D([13748,14120,13134,13597],0); -ELEMENTS[4946] = Fluid3D([12882,13134,13748,12900],0); -ELEMENTS[4947] = Fluid3D([12882,13134,12900,11807],0); -ELEMENTS[4948] = Fluid3D([13597,13476,13748,14234],0); -ELEMENTS[4949] = Fluid3D([14758,14060,14240,13682],0); -ELEMENTS[4950] = Fluid3D([13613,14240,14223,14406],0); -ELEMENTS[4951] = Fluid3D([13682,13748,13613,12956],0); -ELEMENTS[4952] = Fluid3D([13613,13682,12956,13453],0); -ELEMENTS[4953] = Fluid3D([14120,14240,14406,14875],0); -ELEMENTS[4954] = Fluid3D([14120,14240,14875,14743],0); -ELEMENTS[4955] = Fluid3D([14240,13682,14223,14758],0); -ELEMENTS[4956] = Fluid3D([14743,14716,14758,15405],0); -ELEMENTS[4957] = Fluid3D([14240,14223,14406,14818],0); -ELEMENTS[4958] = Fluid3D([13748,12882,12900,13266],0); -ELEMENTS[4959] = Fluid3D([13597,13064,13476,13759],0); -ELEMENTS[4960] = Fluid3D([13064,13476,13759,12756],0); -ELEMENTS[4961] = Fluid3D([14240,14406,14875,14818],0); -ELEMENTS[4962] = Fluid3D([13682,12956,13453,13394],0); -ELEMENTS[4963] = Fluid3D([13682,12956,13394,13266],0); -ELEMENTS[4964] = Fluid3D([13394,13682,13266,14050],0); -ELEMENTS[4965] = Fluid3D([13394,13682,14050,14118],0); -ELEMENTS[4966] = Fluid3D([13682,13266,14050,14060],0); -ELEMENTS[4967] = Fluid3D([13682,12956,13266,13748],0); -ELEMENTS[4968] = Fluid3D([13682,13266,14060,13748],0); -ELEMENTS[4969] = Fluid3D([14050,13682,14060,14758],0); -ELEMENTS[4970] = Fluid3D([13266,14050,14060,13699],0); -ELEMENTS[4971] = Fluid3D([13453,13682,13394,14118],0); -ELEMENTS[4972] = Fluid3D([14060,14050,14758,14476],0); -ELEMENTS[4973] = Fluid3D([14060,14050,14476,13699],0); -ELEMENTS[4974] = Fluid3D([13266,13394,14050,13186],0); -ELEMENTS[4975] = Fluid3D([14234,14716,14743,15011],0); -ELEMENTS[4976] = Fluid3D([13064,12123,12218,11912],0); -ELEMENTS[4977] = Fluid3D([12218,13064,11912,11807],0); -ELEMENTS[4978] = Fluid3D([13597,13064,13759,13947],0); -ELEMENTS[4979] = Fluid3D([12742,13597,13134,13490],0); -ELEMENTS[4980] = Fluid3D([13134,12742,13490,12491],0); -ELEMENTS[4981] = Fluid3D([13134,12742,12491,11807],0); -ELEMENTS[4982] = Fluid3D([14223,13613,14406,13894],0); -ELEMENTS[4983] = Fluid3D([12756,13064,12880,13741],0); -ELEMENTS[4984] = Fluid3D([14406,14223,13894,14777],0); -ELEMENTS[4985] = Fluid3D([14406,14223,14777,14818],0); -ELEMENTS[4986] = Fluid3D([14223,14777,14818,14601],0); -ELEMENTS[4987] = Fluid3D([14777,14818,14601,15245],0); -ELEMENTS[4988] = Fluid3D([14818,14223,14601,14118],0); -ELEMENTS[4989] = Fluid3D([14223,14601,14118,13453],0); -ELEMENTS[4990] = Fluid3D([14777,14818,15245,15400],0); -ELEMENTS[4991] = Fluid3D([14777,14818,15400,14406],0); -ELEMENTS[4992] = Fluid3D([14223,14777,14601,13894],0); -ELEMENTS[4993] = Fluid3D([14601,14777,15245,14498],0); -ELEMENTS[4994] = Fluid3D([15245,14601,14498,14914],0); -ELEMENTS[4995] = Fluid3D([15245,14601,14914,15153],0); -ELEMENTS[4996] = Fluid3D([15245,14601,15153,14818],0); -ELEMENTS[4997] = Fluid3D([14601,15153,14818,14118],0); -ELEMENTS[4998] = Fluid3D([14601,14498,14914,13829],0); -ELEMENTS[4999] = Fluid3D([14601,14777,14498,13894],0); -ELEMENTS[5000] = Fluid3D([13476,13597,13759,14234],0); -ELEMENTS[5001] = Fluid3D([13759,13476,14234,13741],0); -ELEMENTS[5002] = Fluid3D([14118,14223,13453,13682],0); -ELEMENTS[5003] = Fluid3D([12742,13490,12491,12699],0); -ELEMENTS[5004] = Fluid3D([12491,12742,12699,11972],0); -ELEMENTS[5005] = Fluid3D([12742,13490,12699,13210],0); -ELEMENTS[5006] = Fluid3D([12742,12699,11972,12218],0); -ELEMENTS[5007] = Fluid3D([14743,14758,14240,14875],0); -ELEMENTS[5008] = Fluid3D([12491,12742,11972,11807],0); -ELEMENTS[5009] = Fluid3D([12742,13210,13597,13490],0); -ELEMENTS[5010] = Fluid3D([13894,14406,14777,14557],0); -ELEMENTS[5011] = Fluid3D([13894,14406,14557,13827],0); -ELEMENTS[5012] = Fluid3D([13894,14406,13827,13613],0); -ELEMENTS[5013] = Fluid3D([14406,14777,14557,15211],0); -ELEMENTS[5014] = Fluid3D([14406,14777,15211,15400],0); -ELEMENTS[5015] = Fluid3D([14777,15211,15400,15112],0); -ELEMENTS[5016] = Fluid3D([15211,15400,15112,15688],0); -ELEMENTS[5017] = Fluid3D([15211,15400,15688,15809],0); -ELEMENTS[5018] = Fluid3D([15211,15400,15809,15465],0); -ELEMENTS[5019] = Fluid3D([15400,15809,15465,15959],0); -ELEMENTS[5020] = Fluid3D([15809,15465,15959,15903],0); -ELEMENTS[5021] = Fluid3D([15809,15465,15903,15416],0); -ELEMENTS[5022] = Fluid3D([15809,15465,15416,14875],0); -ELEMENTS[5023] = Fluid3D([15400,15688,15809,15959],0); -ELEMENTS[5024] = Fluid3D([15400,15112,15688,15921],0); -ELEMENTS[5025] = Fluid3D([15688,15211,15809,15286],0); -ELEMENTS[5026] = Fluid3D([15112,15211,15688,15158],0); -ELEMENTS[5027] = Fluid3D([15959,15809,15903,16320],0); -ELEMENTS[5028] = Fluid3D([15903,15959,16320,15945],0); -ELEMENTS[5029] = Fluid3D([15959,16320,15945,16415],0); -ELEMENTS[5030] = Fluid3D([15959,15809,16320,16143],0); -ELEMENTS[5031] = Fluid3D([16320,15959,16143,16341],0); -ELEMENTS[5032] = Fluid3D([16320,15959,16341,16415],0); -ELEMENTS[5033] = Fluid3D([15959,16143,16341,15921],0); -ELEMENTS[5034] = Fluid3D([15688,15400,15921,15959],0); -ELEMENTS[5035] = Fluid3D([15903,15809,15416,16290],0); -ELEMENTS[5036] = Fluid3D([15211,15809,15286,14875],0); -ELEMENTS[5037] = Fluid3D([15959,15809,16143,15688],0); -ELEMENTS[5038] = Fluid3D([15400,15112,15921,15245],0); -ELEMENTS[5039] = Fluid3D([15688,15211,15286,15158],0); -ELEMENTS[5040] = Fluid3D([15400,14777,15112,15245],0); -ELEMENTS[5041] = Fluid3D([15465,15903,15416,15405],0); -ELEMENTS[5042] = Fluid3D([15112,15211,15158,14557],0); -ELEMENTS[5043] = Fluid3D([15809,16143,15688,15993],0); -ELEMENTS[5044] = Fluid3D([16143,15688,15993,16141],0); -ELEMENTS[5045] = Fluid3D([16143,15688,16141,15921],0); -ELEMENTS[5046] = Fluid3D([15688,15993,16141,15696],0); -ELEMENTS[5047] = Fluid3D([15688,15993,15696,15286],0); -ELEMENTS[5048] = Fluid3D([15993,15696,15286,15823],0); -ELEMENTS[5049] = Fluid3D([15286,15993,15823,15761],0); -ELEMENTS[5050] = Fluid3D([15286,15993,15761,15809],0); -ELEMENTS[5051] = Fluid3D([15688,15993,15286,15809],0); -ELEMENTS[5052] = Fluid3D([15696,15286,15823,15192],0); -ELEMENTS[5053] = Fluid3D([15696,15286,15192,15158],0); -ELEMENTS[5054] = Fluid3D([15696,15286,15158,15688],0); -ELEMENTS[5055] = Fluid3D([15158,15696,15688,15731],0); -ELEMENTS[5056] = Fluid3D([15158,15696,15731,15327],0); -ELEMENTS[5057] = Fluid3D([15158,15696,15327,15192],0); -ELEMENTS[5058] = Fluid3D([15823,15286,15761,15224],0); -ELEMENTS[5059] = Fluid3D([15286,15823,15192,15224],0); -ELEMENTS[5060] = Fluid3D([15286,15761,15224,15117],0); -ELEMENTS[5061] = Fluid3D([16141,15688,15696,15731],0); -ELEMENTS[5062] = Fluid3D([15286,15761,15117,15809],0); -ELEMENTS[5063] = Fluid3D([15465,15959,15903,15945],0); -ELEMENTS[5064] = Fluid3D([15192,15286,15224,14699],0); -ELEMENTS[5065] = Fluid3D([15211,15286,15158,14699],0); -ELEMENTS[5066] = Fluid3D([15696,15731,15327,15979],0); -ELEMENTS[5067] = Fluid3D([15993,15823,15761,16416],0); -ELEMENTS[5068] = Fluid3D([15731,15158,15327,14976],0); -ELEMENTS[5069] = Fluid3D([15327,15696,15979,15720],0); -ELEMENTS[5070] = Fluid3D([15158,15327,14976,14611],0); -ELEMENTS[5071] = Fluid3D([15158,15327,14611,15192],0); -ELEMENTS[5072] = Fluid3D([15993,16143,16141,16537],0); -ELEMENTS[5073] = Fluid3D([16143,16141,16537,16378],0); -ELEMENTS[5074] = Fluid3D([16143,16141,16378,15921],0); -ELEMENTS[5075] = Fluid3D([15327,15696,15720,15192],0); -ELEMENTS[5076] = Fluid3D([15731,15158,14976,15112],0); -ELEMENTS[5077] = Fluid3D([15761,15993,16416,16290],0); -ELEMENTS[5078] = Fluid3D([15192,15286,14699,15158],0); -ELEMENTS[5079] = Fluid3D([15696,15731,15979,16141],0); -ELEMENTS[5080] = Fluid3D([16143,15688,15921,15959],0); -ELEMENTS[5081] = Fluid3D([14777,15211,15112,14557],0); -ELEMENTS[5082] = Fluid3D([15224,15286,15117,14699],0); -ELEMENTS[5083] = Fluid3D([15696,15979,15720,16229],0); -ELEMENTS[5084] = Fluid3D([15823,15696,15192,15720],0); -ELEMENTS[5085] = Fluid3D([15696,15979,16229,16141],0); -ELEMENTS[5086] = Fluid3D([15224,15192,14699,14806],0); -ELEMENTS[5087] = Fluid3D([15224,15192,14806,15302],0); -ELEMENTS[5088] = Fluid3D([15224,15192,15302,15823],0); -ELEMENTS[5089] = Fluid3D([15959,16341,16415,15827],0); -ELEMENTS[5090] = Fluid3D([15688,15158,15731,15112],0); -ELEMENTS[5091] = Fluid3D([15993,16143,16537,16290],0); -ELEMENTS[5092] = Fluid3D([16143,16320,16341,16677],0); -ELEMENTS[5093] = Fluid3D([16320,16341,16677,16810],0); -ELEMENTS[5094] = Fluid3D([15993,15696,15823,16229],0); -ELEMENTS[5095] = Fluid3D([14976,15158,14611,14557],0); -ELEMENTS[5096] = Fluid3D([15993,15823,16416,16229],0); -ELEMENTS[5097] = Fluid3D([15903,15809,16290,16320],0); -ELEMENTS[5098] = Fluid3D([16290,15903,16320,16191],0); -ELEMENTS[5099] = Fluid3D([16290,15903,16191,15955],0); -ELEMENTS[5100] = Fluid3D([15903,16191,15955,15405],0); -ELEMENTS[5101] = Fluid3D([15903,16320,16191,15945],0); -ELEMENTS[5102] = Fluid3D([16290,15903,15955,15416],0); -ELEMENTS[5103] = Fluid3D([16191,15903,15945,15405],0); -ELEMENTS[5104] = Fluid3D([15903,15955,15416,15405],0); -ELEMENTS[5105] = Fluid3D([16191,16290,15955,16493],0); -ELEMENTS[5106] = Fluid3D([15955,16191,16493,16190],0); -ELEMENTS[5107] = Fluid3D([16290,15955,16493,16333],0); -ELEMENTS[5108] = Fluid3D([15955,16493,16333,16218],0); -ELEMENTS[5109] = Fluid3D([15955,16493,16218,16190],0); -ELEMENTS[5110] = Fluid3D([16290,15955,16333,15761],0); -ELEMENTS[5111] = Fluid3D([16333,15955,16218,15805],0); -ELEMENTS[5112] = Fluid3D([15955,16218,15805,15632],0); -ELEMENTS[5113] = Fluid3D([15761,15224,15117,15402],0); -ELEMENTS[5114] = Fluid3D([15761,15224,15402,15751],0); -ELEMENTS[5115] = Fluid3D([15761,15224,15751,15823],0); -ELEMENTS[5116] = Fluid3D([14406,14557,13827,14699],0); -ELEMENTS[5117] = Fluid3D([16537,16143,16378,16677],0); -ELEMENTS[5118] = Fluid3D([16378,16537,16677,16989],0); -ELEMENTS[5119] = Fluid3D([16537,16677,16989,16917],0); -ELEMENTS[5120] = Fluid3D([16537,16677,16917,16290],0); -ELEMENTS[5121] = Fluid3D([16677,16378,16989,16965],0); -ELEMENTS[5122] = Fluid3D([16677,16378,16965,16341],0); -ELEMENTS[5123] = Fluid3D([16537,16143,16677,16290],0); -ELEMENTS[5124] = Fluid3D([16143,16378,16677,16341],0); -ELEMENTS[5125] = Fluid3D([16677,16989,16917,17144],0); -ELEMENTS[5126] = Fluid3D([16989,16677,16965,17144],0); -ELEMENTS[5127] = Fluid3D([16677,16965,17144,16810],0); -ELEMENTS[5128] = Fluid3D([16917,16677,17144,16695],0); -ELEMENTS[5129] = Fluid3D([16989,16537,16917,16981],0); -ELEMENTS[5130] = Fluid3D([16537,16917,16981,16416],0); -ELEMENTS[5131] = Fluid3D([16378,16989,16965,17062],0); -ELEMENTS[5132] = Fluid3D([16378,16537,16989,16710],0); -ELEMENTS[5133] = Fluid3D([16537,16989,16710,16981],0); -ELEMENTS[5134] = Fluid3D([16989,16378,16710,17062],0); -ELEMENTS[5135] = Fluid3D([16989,16917,17144,17508],0); -ELEMENTS[5136] = Fluid3D([16917,16989,16981,17508],0); -ELEMENTS[5137] = Fluid3D([16965,16989,17144,17371],0); -ELEMENTS[5138] = Fluid3D([16378,16537,16710,16141],0); -ELEMENTS[5139] = Fluid3D([16710,16378,16141,16453],0); -ELEMENTS[5140] = Fluid3D([16537,16710,16141,16229],0); -ELEMENTS[5141] = Fluid3D([16141,16710,16453,15979],0); -ELEMENTS[5142] = Fluid3D([16378,16141,16453,16200],0); -ELEMENTS[5143] = Fluid3D([16378,16141,16200,15921],0); -ELEMENTS[5144] = Fluid3D([16141,16453,16200,15731],0); -ELEMENTS[5145] = Fluid3D([16710,16378,16453,17062],0); -ELEMENTS[5146] = Fluid3D([15112,15688,15921,15731],0); -ELEMENTS[5147] = Fluid3D([15192,14806,15302,14876],0); -ELEMENTS[5148] = Fluid3D([15192,14806,14876,14611],0); -ELEMENTS[5149] = Fluid3D([15302,15192,14876,15720],0); -ELEMENTS[5150] = Fluid3D([15805,15955,15632,15416],0); -ELEMENTS[5151] = Fluid3D([16493,16290,16333,16745],0); -ELEMENTS[5152] = Fluid3D([16333,16493,16745,16734],0); -ELEMENTS[5153] = Fluid3D([16290,16333,16745,16416],0); -ELEMENTS[5154] = Fluid3D([16493,16745,16734,17006],0); -ELEMENTS[5155] = Fluid3D([16333,16493,16734,16218],0); -ELEMENTS[5156] = Fluid3D([16745,16333,16734,16617],0); -ELEMENTS[5157] = Fluid3D([16745,16333,16617,16416],0); -ELEMENTS[5158] = Fluid3D([15327,15731,14976,15467],0); -ELEMENTS[5159] = Fluid3D([14976,15327,15467,14886],0); -ELEMENTS[5160] = Fluid3D([15731,14976,15467,15371],0); -ELEMENTS[5161] = Fluid3D([15731,14976,15371,15112],0); -ELEMENTS[5162] = Fluid3D([14976,15467,15371,14971],0); -ELEMENTS[5163] = Fluid3D([14976,15327,14886,14611],0); -ELEMENTS[5164] = Fluid3D([15467,14976,14886,14971],0); -ELEMENTS[5165] = Fluid3D([15955,16218,15632,16190],0); -ELEMENTS[5166] = Fluid3D([13064,12123,11912,12201],0); -ELEMENTS[5167] = Fluid3D([11912,13064,12201,11807],0); -ELEMENTS[5168] = Fluid3D([12201,11912,11807,11441],0); -ELEMENTS[5169] = Fluid3D([12201,11912,11441,12123],0); -ELEMENTS[5170] = Fluid3D([11912,11807,11441,11257],0); -ELEMENTS[5171] = Fluid3D([11912,11807,11257,12218],0); -ELEMENTS[5172] = Fluid3D([11441,11912,11257,12123],0); -ELEMENTS[5173] = Fluid3D([15979,15720,16229,16254],0); -ELEMENTS[5174] = Fluid3D([16229,15979,16254,16543],0); -ELEMENTS[5175] = Fluid3D([16229,15979,16543,16710],0); -ELEMENTS[5176] = Fluid3D([15192,14699,14806,14611],0); -ELEMENTS[5177] = Fluid3D([15731,15327,15979,15467],0); -ELEMENTS[5178] = Fluid3D([13613,14120,14406,13827],0); -ELEMENTS[5179] = Fluid3D([15117,15761,15402,15416],0); -ELEMENTS[5180] = Fluid3D([15117,15761,15416,15809],0); -ELEMENTS[5181] = Fluid3D([15416,15117,15809,14875],0); -ELEMENTS[5182] = Fluid3D([15416,15117,14875,14953],0); -ELEMENTS[5183] = Fluid3D([15117,14875,14953,14444],0); -ELEMENTS[5184] = Fluid3D([15117,14875,14444,14699],0); -ELEMENTS[5185] = Fluid3D([15416,15117,14953,15402],0); -ELEMENTS[5186] = Fluid3D([15117,14953,15402,14444],0); -ELEMENTS[5187] = Fluid3D([14875,15416,14953,14743],0); -ELEMENTS[5188] = Fluid3D([14875,14953,14444,14274],0); -ELEMENTS[5189] = Fluid3D([14875,14953,14274,14743],0); -ELEMENTS[5190] = Fluid3D([14444,14875,14274,14120],0); -ELEMENTS[5191] = Fluid3D([14274,14444,14120,13490],0); -ELEMENTS[5192] = Fluid3D([14444,14875,14120,14699],0); -ELEMENTS[5193] = Fluid3D([14875,14274,14120,14743],0); -ELEMENTS[5194] = Fluid3D([14444,15117,14699,15224],0); -ELEMENTS[5195] = Fluid3D([14953,14444,14274,14391],0); -ELEMENTS[5196] = Fluid3D([14444,14274,14391,13490],0); -ELEMENTS[5197] = Fluid3D([14953,14444,14391,15402],0); -ELEMENTS[5198] = Fluid3D([14274,14953,14391,14642],0); -ELEMENTS[5199] = Fluid3D([14223,13613,13894,13453],0); -ELEMENTS[5200] = Fluid3D([12218,13210,12742,12699],0); -ELEMENTS[5201] = Fluid3D([14498,15245,14914,15284],0); -ELEMENTS[5202] = Fluid3D([15245,14914,15284,15801],0); -ELEMENTS[5203] = Fluid3D([16218,16333,15805,16126],0); -ELEMENTS[5204] = Fluid3D([16333,15805,16126,15998],0); -ELEMENTS[5205] = Fluid3D([16333,15805,15998,15761],0); -ELEMENTS[5206] = Fluid3D([14716,14743,15011,15405],0); -ELEMENTS[5207] = Fluid3D([15720,15696,16229,15823],0); -ELEMENTS[5208] = Fluid3D([13134,13748,12900,13613],0); -ELEMENTS[5209] = Fluid3D([13748,12900,13613,12956],0); -ELEMENTS[5210] = Fluid3D([12900,13613,12956,12646],0); -ELEMENTS[5211] = Fluid3D([15979,15327,15720,15666],0); -ELEMENTS[5212] = Fluid3D([15327,15720,15666,15125],0); -ELEMENTS[5213] = Fluid3D([15327,15720,15125,15192],0); -ELEMENTS[5214] = Fluid3D([15979,15327,15666,15467],0); -ELEMENTS[5215] = Fluid3D([15666,15327,15125,14886],0); -ELEMENTS[5216] = Fluid3D([15720,15666,15125,15642],0); -ELEMENTS[5217] = Fluid3D([15224,15117,15402,14444],0); -ELEMENTS[5218] = Fluid3D([13490,13134,12491,13586],0); -ELEMENTS[5219] = Fluid3D([13134,12491,13586,12921],0); -ELEMENTS[5220] = Fluid3D([13134,12491,12921,12341],0); -ELEMENTS[5221] = Fluid3D([13490,13134,13586,14120],0); -ELEMENTS[5222] = Fluid3D([13586,13134,12921,14120],0); -ELEMENTS[5223] = Fluid3D([12921,13134,12341,12900],0); -ELEMENTS[5224] = Fluid3D([13134,12341,12900,11807],0); -ELEMENTS[5225] = Fluid3D([13134,12491,12341,11807],0); -ELEMENTS[5226] = Fluid3D([12491,12921,12341,12079],0); -ELEMENTS[5227] = Fluid3D([12341,12491,12079,11807],0); -ELEMENTS[5228] = Fluid3D([12491,12921,12079,12803],0); -ELEMENTS[5229] = Fluid3D([12491,12921,12803,13586],0); -ELEMENTS[5230] = Fluid3D([14806,15224,15302,14949],0); -ELEMENTS[5231] = Fluid3D([15224,15302,14949,15751],0); -ELEMENTS[5232] = Fluid3D([14806,15224,14949,14444],0); -ELEMENTS[5233] = Fluid3D([13682,13613,14223,13453],0); -ELEMENTS[5234] = Fluid3D([15823,15761,16416,15751],0); -ELEMENTS[5235] = Fluid3D([16218,15805,15632,15396],0); -ELEMENTS[5236] = Fluid3D([14699,15224,14806,14444],0); -ELEMENTS[5237] = Fluid3D([12699,12491,11972,12234],0); -ELEMENTS[5238] = Fluid3D([12491,11972,12234,12079],0); -ELEMENTS[5239] = Fluid3D([14406,14120,14875,14699],0); -ELEMENTS[5240] = Fluid3D([15402,15761,15751,15998],0); -ELEMENTS[5241] = Fluid3D([15751,15402,15998,15477],0); -ELEMENTS[5242] = Fluid3D([15998,15751,15477,16059],0); -ELEMENTS[5243] = Fluid3D([15998,15751,16059,16289],0); -ELEMENTS[5244] = Fluid3D([15998,15751,16289,16416],0); -ELEMENTS[5245] = Fluid3D([15751,15477,16059,15520],0); -ELEMENTS[5246] = Fluid3D([15751,16059,16289,16041],0); -ELEMENTS[5247] = Fluid3D([15751,15477,15520,14949],0); -ELEMENTS[5248] = Fluid3D([16059,15998,16289,16492],0); -ELEMENTS[5249] = Fluid3D([16059,15751,15520,16041],0); -ELEMENTS[5250] = Fluid3D([16289,15751,16041,15823],0); -ELEMENTS[5251] = Fluid3D([15998,16289,16492,16617],0); -ELEMENTS[5252] = Fluid3D([16289,16492,16617,16833],0); -ELEMENTS[5253] = Fluid3D([16492,16617,16833,16845],0); -ELEMENTS[5254] = Fluid3D([16492,16617,16845,16126],0); -ELEMENTS[5255] = Fluid3D([16833,16492,16845,16759],0); -ELEMENTS[5256] = Fluid3D([16833,16492,16759,16059],0); -ELEMENTS[5257] = Fluid3D([16492,16845,16759,16593],0); -ELEMENTS[5258] = Fluid3D([16492,16845,16593,16126],0); -ELEMENTS[5259] = Fluid3D([16617,16833,16845,17147],0); -ELEMENTS[5260] = Fluid3D([16845,16617,17147,17052],0); -ELEMENTS[5261] = Fluid3D([16845,16617,17052,16715],0); -ELEMENTS[5262] = Fluid3D([16845,16617,16715,16126],0); -ELEMENTS[5263] = Fluid3D([16059,15998,16492,16051],0); -ELEMENTS[5264] = Fluid3D([16059,15998,16051,15477],0); -ELEMENTS[5265] = Fluid3D([15751,15520,16041,15302],0); -ELEMENTS[5266] = Fluid3D([16759,16492,16593,16051],0); -ELEMENTS[5267] = Fluid3D([15751,16289,16416,15823],0); -ELEMENTS[5268] = Fluid3D([15998,16492,16051,16126],0); -ELEMENTS[5269] = Fluid3D([16617,17147,17052,16745],0); -ELEMENTS[5270] = Fluid3D([16617,16833,17147,16804],0); -ELEMENTS[5271] = Fluid3D([16617,16833,16804,16289],0); -ELEMENTS[5272] = Fluid3D([17147,16617,16804,16745],0); -ELEMENTS[5273] = Fluid3D([16617,17052,16715,16734],0); -ELEMENTS[5274] = Fluid3D([17052,16715,16734,16959],0); -ELEMENTS[5275] = Fluid3D([16734,17052,16959,17006],0); -ELEMENTS[5276] = Fluid3D([16617,17052,16734,16745],0); -ELEMENTS[5277] = Fluid3D([16715,16734,16959,16218],0); -ELEMENTS[5278] = Fluid3D([16715,16617,16734,16333],0); -ELEMENTS[5279] = Fluid3D([17052,16715,16959,17086],0); -ELEMENTS[5280] = Fluid3D([16959,17052,17086,17372],0); -ELEMENTS[5281] = Fluid3D([16959,17052,17372,17175],0); -ELEMENTS[5282] = Fluid3D([16959,17052,17175,17006],0); -ELEMENTS[5283] = Fluid3D([17052,17175,17006,17374],0); -ELEMENTS[5284] = Fluid3D([17175,17006,17374,17451],0); -ELEMENTS[5285] = Fluid3D([15751,15402,15477,14949],0); -ELEMENTS[5286] = Fluid3D([16734,17052,17006,16745],0); -ELEMENTS[5287] = Fluid3D([16845,16833,16759,17198],0); -ELEMENTS[5288] = Fluid3D([16833,16759,17198,16916],0); -ELEMENTS[5289] = Fluid3D([16833,16759,16916,16424],0); -ELEMENTS[5290] = Fluid3D([16833,16759,16424,16059],0); -ELEMENTS[5291] = Fluid3D([16759,16845,17198,17131],0); -ELEMENTS[5292] = Fluid3D([16759,16845,17131,16593],0); -ELEMENTS[5293] = Fluid3D([16759,17198,16916,17084],0); -ELEMENTS[5294] = Fluid3D([17198,16759,17131,17084],0); -ELEMENTS[5295] = Fluid3D([16916,16759,17084,16634],0); -ELEMENTS[5296] = Fluid3D([16916,16759,16634,16424],0); -ELEMENTS[5297] = Fluid3D([17086,16959,17372,17223],0); -ELEMENTS[5298] = Fluid3D([17086,16959,17223,16784],0); -ELEMENTS[5299] = Fluid3D([16959,17372,17223,17308],0); -ELEMENTS[5300] = Fluid3D([17086,16959,16784,16715],0); -ELEMENTS[5301] = Fluid3D([16959,17372,17308,17175],0); -ELEMENTS[5302] = Fluid3D([17372,17223,17308,17597],0); -ELEMENTS[5303] = Fluid3D([17308,17372,17597,17600],0); -ELEMENTS[5304] = Fluid3D([17308,17372,17600,17175],0); -ELEMENTS[5305] = Fluid3D([16059,16289,16041,16424],0); -ELEMENTS[5306] = Fluid3D([16041,16059,16424,15997],0); -ELEMENTS[5307] = Fluid3D([16059,16424,15997,16307],0); -ELEMENTS[5308] = Fluid3D([16059,16424,16307,16759],0); -ELEMENTS[5309] = Fluid3D([16059,16289,16424,16833],0); -ELEMENTS[5310] = Fluid3D([16424,15997,16307,16634],0); -ELEMENTS[5311] = Fluid3D([16307,16424,16634,16759],0); -ELEMENTS[5312] = Fluid3D([16634,16307,16759,16676],0); -ELEMENTS[5313] = Fluid3D([16634,16307,16676,16308],0); -ELEMENTS[5314] = Fluid3D([16634,16307,16308,15997],0); -ELEMENTS[5315] = Fluid3D([15997,16059,16307,15702],0); -ELEMENTS[5316] = Fluid3D([16424,16041,15997,16382],0); -ELEMENTS[5317] = Fluid3D([15997,16424,16382,16634],0); -ELEMENTS[5318] = Fluid3D([16059,16307,15702,16051],0); -ELEMENTS[5319] = Fluid3D([16307,16676,16308,16158],0); -ELEMENTS[5320] = Fluid3D([15997,16059,15702,15520],0); -ELEMENTS[5321] = Fluid3D([15997,16059,15520,16041],0); -ELEMENTS[5322] = Fluid3D([16424,16041,16382,16687],0); -ELEMENTS[5323] = Fluid3D([16424,16041,16687,16289],0); -ELEMENTS[5324] = Fluid3D([16308,16307,16158,15702],0); -ELEMENTS[5325] = Fluid3D([16307,16759,16676,16593],0); -ELEMENTS[5326] = Fluid3D([16676,16634,16308,16795],0); -ELEMENTS[5327] = Fluid3D([16634,16308,16795,16502],0); -ELEMENTS[5328] = Fluid3D([16634,16308,16502,15997],0); -ELEMENTS[5329] = Fluid3D([16307,16676,16158,16593],0); -ELEMENTS[5330] = Fluid3D([15702,15997,15520,15415],0); -ELEMENTS[5331] = Fluid3D([15997,15520,15415,15604],0); -ELEMENTS[5332] = Fluid3D([15997,15520,15604,16041],0); -ELEMENTS[5333] = Fluid3D([16676,16634,16795,17084],0); -ELEMENTS[5334] = Fluid3D([16382,16424,16687,16916],0); -ELEMENTS[5335] = Fluid3D([15415,15997,15604,15867],0); -ELEMENTS[5336] = Fluid3D([16795,16634,16502,17077],0); -ELEMENTS[5337] = Fluid3D([15997,15604,15867,16382],0); -ELEMENTS[5338] = Fluid3D([16759,16634,16676,17084],0); -ELEMENTS[5339] = Fluid3D([15520,15415,15604,14965],0); -ELEMENTS[5340] = Fluid3D([15604,15520,14965,15302],0); -ELEMENTS[5341] = Fluid3D([15415,15997,15867,15929],0); -ELEMENTS[5342] = Fluid3D([15415,15997,15929,15702],0); -ELEMENTS[5343] = Fluid3D([16059,15702,15520,15477],0); -ELEMENTS[5344] = Fluid3D([15520,15415,14965,14979],0); -ELEMENTS[5345] = Fluid3D([16307,15997,15702,16308],0); -ELEMENTS[5346] = Fluid3D([16676,16308,16158,16721],0); -ELEMENTS[5347] = Fluid3D([16308,16676,16795,16721],0); -ELEMENTS[5348] = Fluid3D([16676,16795,16721,17191],0); -ELEMENTS[5349] = Fluid3D([15520,15415,14979,15702],0); -ELEMENTS[5350] = Fluid3D([14965,15520,14979,14949],0); -ELEMENTS[5351] = Fluid3D([14965,15520,14949,15302],0); -ELEMENTS[5352] = Fluid3D([15520,14979,14949,15477],0); -ELEMENTS[5353] = Fluid3D([14979,14965,14949,14361],0); -ELEMENTS[5354] = Fluid3D([14965,14949,14361,14806],0); -ELEMENTS[5355] = Fluid3D([16959,17223,16784,16885],0); -ELEMENTS[5356] = Fluid3D([16959,17223,16885,17308],0); -ELEMENTS[5357] = Fluid3D([16784,16959,16885,16469],0); -ELEMENTS[5358] = Fluid3D([16784,16959,16469,16715],0); -ELEMENTS[5359] = Fluid3D([16617,16715,16126,16333],0); -ELEMENTS[5360] = Fluid3D([16959,16885,16469,16803],0); -ELEMENTS[5361] = Fluid3D([16959,16885,16803,17308],0); -ELEMENTS[5362] = Fluid3D([17147,16845,17052,17384],0); -ELEMENTS[5363] = Fluid3D([16845,17052,17384,17086],0); -ELEMENTS[5364] = Fluid3D([16845,17052,17086,16715],0); -ELEMENTS[5365] = Fluid3D([17086,16845,16715,16593],0); -ELEMENTS[5366] = Fluid3D([17384,16845,17086,17131],0); -ELEMENTS[5367] = Fluid3D([16845,16715,16593,16126],0); -ELEMENTS[5368] = Fluid3D([17147,16845,17384,17198],0); -ELEMENTS[5369] = Fluid3D([16308,16795,16502,16406],0); -ELEMENTS[5370] = Fluid3D([15997,15867,15929,16502],0); -ELEMENTS[5371] = Fluid3D([15415,14965,14979,14701],0); -ELEMENTS[5372] = Fluid3D([14979,15415,14701,15116],0); -ELEMENTS[5373] = Fluid3D([14979,15415,15116,15702],0); -ELEMENTS[5374] = Fluid3D([16051,15998,16126,15805],0); -ELEMENTS[5375] = Fluid3D([16041,16382,16687,16145],0); -ELEMENTS[5376] = Fluid3D([16687,16041,16145,16211],0); -ELEMENTS[5377] = Fluid3D([16687,16041,16211,16289],0); -ELEMENTS[5378] = Fluid3D([16145,16687,16211,16606],0); -ELEMENTS[5379] = Fluid3D([16687,16211,16606,16804],0); -ELEMENTS[5380] = Fluid3D([16145,16687,16606,16879],0); -ELEMENTS[5381] = Fluid3D([16606,16145,16879,16526],0); -ELEMENTS[5382] = Fluid3D([16687,16606,16879,17200],0); -ELEMENTS[5383] = Fluid3D([16041,16145,16211,15703],0); -ELEMENTS[5384] = Fluid3D([16211,16041,15703,15823],0); -ELEMENTS[5385] = Fluid3D([15703,16211,15823,16229],0); -ELEMENTS[5386] = Fluid3D([16211,15823,16229,16416],0); -ELEMENTS[5387] = Fluid3D([16211,15823,16416,16289],0); -ELEMENTS[5388] = Fluid3D([16416,16211,16289,16804],0); -ELEMENTS[5389] = Fluid3D([16289,16416,16804,16617],0); -ELEMENTS[5390] = Fluid3D([16041,16145,15703,15604],0); -ELEMENTS[5391] = Fluid3D([15604,15415,15867,15234],0); -ELEMENTS[5392] = Fluid3D([15867,15604,15234,15765],0); -ELEMENTS[5393] = Fluid3D([15867,15604,15765,16382],0); -ELEMENTS[5394] = Fluid3D([16289,16059,16492,16833],0); -ELEMENTS[5395] = Fluid3D([17223,17086,16784,17112],0); -ELEMENTS[5396] = Fluid3D([17052,17372,17175,17374],0); -ELEMENTS[5397] = Fluid3D([16492,16059,16051,16759],0); -ELEMENTS[5398] = Fluid3D([17052,17086,17372,17384],0); -ELEMENTS[5399] = Fluid3D([15867,15415,15929,15463],0); -ELEMENTS[5400] = Fluid3D([15415,15929,15463,15116],0); -ELEMENTS[5401] = Fluid3D([15867,15415,15463,15234],0); -ELEMENTS[5402] = Fluid3D([16833,17147,16804,17129],0); -ELEMENTS[5403] = Fluid3D([16804,16833,17129,16687],0); -ELEMENTS[5404] = Fluid3D([16333,15955,15805,15761],0); -ELEMENTS[5405] = Fluid3D([15993,16141,15696,16229],0); -ELEMENTS[5406] = Fluid3D([14743,14234,15011,14707],0); -ELEMENTS[5407] = Fluid3D([14743,14234,14707,14274],0); -ELEMENTS[5408] = Fluid3D([14707,14743,14274,14953],0); -ELEMENTS[5409] = Fluid3D([14274,14707,14953,14642],0); -ELEMENTS[5410] = Fluid3D([12491,13490,13586,13287],0); -ELEMENTS[5411] = Fluid3D([12491,13490,13287,12699],0); -ELEMENTS[5412] = Fluid3D([13597,13134,13490,14120],0); -ELEMENTS[5413] = Fluid3D([15720,16229,16254,16145],0); -ELEMENTS[5414] = Fluid3D([12123,12218,11912,11257],0); -ELEMENTS[5415] = Fluid3D([12545,12271,12581,11612],0); -ELEMENTS[5416] = Fluid3D([12640,12545,11666,12772],0); -ELEMENTS[5417] = Fluid3D([12214,12018,11434,12646],0); -ELEMENTS[5418] = Fluid3D([12271,12828,11962,12222],0); -ELEMENTS[5419] = Fluid3D([13699,12828,13518,12626],0); -ELEMENTS[5420] = Fluid3D([10656,11612,11441,11086],0); -ELEMENTS[5421] = Fluid3D([11441,10656,11086,10509],0); -ELEMENTS[5422] = Fluid3D([10656,11086,10509,10048],0); -ELEMENTS[5423] = Fluid3D([10656,11086,10048,10753],0); -ELEMENTS[5424] = Fluid3D([10656,11612,11086,10753],0); -ELEMENTS[5425] = Fluid3D([11086,10509,10048,10461],0); -ELEMENTS[5426] = Fluid3D([11086,10509,10461,11395],0); -ELEMENTS[5427] = Fluid3D([10048,11086,10461,10576],0); -ELEMENTS[5428] = Fluid3D([10048,11086,10576,10753],0); -ELEMENTS[5429] = Fluid3D([10461,10048,10576,9644],0); -ELEMENTS[5430] = Fluid3D([10509,10048,10461,9608],0); -ELEMENTS[5431] = Fluid3D([10048,10576,9644,9741],0); -ELEMENTS[5432] = Fluid3D([10576,9644,9741,9914],0); -ELEMENTS[5433] = Fluid3D([10461,10048,9644,9608],0); -ELEMENTS[5434] = Fluid3D([10509,10048,9608,9696],0); -ELEMENTS[5435] = Fluid3D([10048,10576,9741,10753],0); -ELEMENTS[5436] = Fluid3D([10576,9644,9914,10368],0); -ELEMENTS[5437] = Fluid3D([10576,9644,10368,10461],0); -ELEMENTS[5438] = Fluid3D([9644,9914,10368,9512],0); -ELEMENTS[5439] = Fluid3D([9644,9914,9512,8968],0); -ELEMENTS[5440] = Fluid3D([9512,9644,8968,8772],0); -ELEMENTS[5441] = Fluid3D([9644,9914,8968,9741],0); -ELEMENTS[5442] = Fluid3D([9512,9644,8772,9585],0); -ELEMENTS[5443] = Fluid3D([9512,9644,9585,10368],0); -ELEMENTS[5444] = Fluid3D([8772,9512,9585,8851],0); -ELEMENTS[5445] = Fluid3D([8772,9512,8851,8444],0); -ELEMENTS[5446] = Fluid3D([8772,9512,8444,8968],0); -ELEMENTS[5447] = Fluid3D([9585,8772,8851,8747],0); -ELEMENTS[5448] = Fluid3D([9585,8772,8747,9608],0); -ELEMENTS[5449] = Fluid3D([8851,9585,8747,9993],0); -ELEMENTS[5450] = Fluid3D([9914,10368,9512,10138],0); -ELEMENTS[5451] = Fluid3D([10368,9512,10138,10686],0); -ELEMENTS[5452] = Fluid3D([10138,10368,10686,11046],0); -ELEMENTS[5453] = Fluid3D([10686,10138,11046,10406],0); -ELEMENTS[5454] = Fluid3D([10368,10686,11046,11232],0); -ELEMENTS[5455] = Fluid3D([10686,11046,11232,11552],0); -ELEMENTS[5456] = Fluid3D([10368,10686,11232,11038],0); -ELEMENTS[5457] = Fluid3D([10138,10368,11046,9914],0); -ELEMENTS[5458] = Fluid3D([9512,9914,10138,9373],0); -ELEMENTS[5459] = Fluid3D([9512,9914,9373,8968],0); -ELEMENTS[5460] = Fluid3D([9914,10138,9373,10167],0); -ELEMENTS[5461] = Fluid3D([9373,9914,10167,9321],0); -ELEMENTS[5462] = Fluid3D([9373,9914,9321,8968],0); -ELEMENTS[5463] = Fluid3D([9914,10138,10167,11046],0); -ELEMENTS[5464] = Fluid3D([9914,10576,10368,11046],0); -ELEMENTS[5465] = Fluid3D([11046,10368,11232,10576],0); -ELEMENTS[5466] = Fluid3D([11086,10461,10576,11226],0); -ELEMENTS[5467] = Fluid3D([11086,10461,11226,11395],0); -ELEMENTS[5468] = Fluid3D([10461,10576,11226,11232],0); -ELEMENTS[5469] = Fluid3D([10576,11086,11226,11962],0); -ELEMENTS[5470] = Fluid3D([11086,11226,11962,11860],0); -ELEMENTS[5471] = Fluid3D([11226,11962,11860,11549],0); -ELEMENTS[5472] = Fluid3D([11441,10656,10509,10540],0); -ELEMENTS[5473] = Fluid3D([11612,11441,11086,11860],0); -ELEMENTS[5474] = Fluid3D([9512,9585,8851,9794],0); -ELEMENTS[5475] = Fluid3D([9512,9585,9794,10368],0); -ELEMENTS[5476] = Fluid3D([9585,8851,9794,9993],0); -ELEMENTS[5477] = Fluid3D([9794,9585,9993,10368],0); -ELEMENTS[5478] = Fluid3D([8851,9512,9794,9111],0); -ELEMENTS[5479] = Fluid3D([9512,9794,9111,9862],0); -ELEMENTS[5480] = Fluid3D([9794,9111,9862,9905],0); -ELEMENTS[5481] = Fluid3D([9111,9862,9905,9430],0); -ELEMENTS[5482] = Fluid3D([9862,9905,9430,10406],0); -ELEMENTS[5483] = Fluid3D([9862,9905,10406,10686],0); -ELEMENTS[5484] = Fluid3D([9862,9905,10686,9794],0); -ELEMENTS[5485] = Fluid3D([10686,9862,9794,9512],0); -ELEMENTS[5486] = Fluid3D([9111,9862,9430,9373],0); -ELEMENTS[5487] = Fluid3D([8851,9512,9111,8444],0); -ELEMENTS[5488] = Fluid3D([9794,8851,9111,9118],0); -ELEMENTS[5489] = Fluid3D([9794,8851,9118,9993],0); -ELEMENTS[5490] = Fluid3D([8851,9111,9118,8290],0); -ELEMENTS[5491] = Fluid3D([9111,9794,9118,9905],0); -ELEMENTS[5492] = Fluid3D([9111,9118,8290,8830],0); -ELEMENTS[5493] = Fluid3D([9118,8290,8830,8388],0); -ELEMENTS[5494] = Fluid3D([8290,9111,8830,8382],0); -ELEMENTS[5495] = Fluid3D([9111,9118,8830,9905],0); -ELEMENTS[5496] = Fluid3D([8830,9118,8388,9265],0); -ELEMENTS[5497] = Fluid3D([8830,9118,9265,9905],0); -ELEMENTS[5498] = Fluid3D([9118,8388,9265,9061],0); -ELEMENTS[5499] = Fluid3D([8388,9265,9061,8820],0); -ELEMENTS[5500] = Fluid3D([9118,8388,9061,8650],0); -ELEMENTS[5501] = Fluid3D([8388,9061,8650,8132],0); -ELEMENTS[5502] = Fluid3D([8388,9061,8132,8820],0); -ELEMENTS[5503] = Fluid3D([9118,8388,8650,8290],0); -ELEMENTS[5504] = Fluid3D([8290,9111,8382,8444],0); -ELEMENTS[5505] = Fluid3D([8290,8830,8388,7905],0); -ELEMENTS[5506] = Fluid3D([8290,8830,7905,8382],0); -ELEMENTS[5507] = Fluid3D([8830,8388,7905,8455],0); -ELEMENTS[5508] = Fluid3D([8830,8388,8455,9265],0); -ELEMENTS[5509] = Fluid3D([8388,7905,8455,7692],0); -ELEMENTS[5510] = Fluid3D([7905,8455,7692,7667],0); -ELEMENTS[5511] = Fluid3D([8455,7692,7667,7972],0); -ELEMENTS[5512] = Fluid3D([8455,7692,7972,8820],0); -ELEMENTS[5513] = Fluid3D([8388,8290,7905,7578],0); -ELEMENTS[5514] = Fluid3D([8290,7905,7578,7486],0); -ELEMENTS[5515] = Fluid3D([8290,7905,7486,8382],0); -ELEMENTS[5516] = Fluid3D([8388,8290,7578,8650],0); -ELEMENTS[5517] = Fluid3D([7905,8455,7667,8330],0); -ELEMENTS[5518] = Fluid3D([8455,7667,8330,8492],0); -ELEMENTS[5519] = Fluid3D([7667,7905,8330,7495],0); -ELEMENTS[5520] = Fluid3D([7905,8455,8330,8830],0); -ELEMENTS[5521] = Fluid3D([7905,8330,7495,8382],0); -ELEMENTS[5522] = Fluid3D([7667,7905,7495,7043],0); -ELEMENTS[5523] = Fluid3D([7667,7905,7043,7692],0); -ELEMENTS[5524] = Fluid3D([7905,7495,7043,7486],0); -ELEMENTS[5525] = Fluid3D([8388,7905,7692,7578],0); -ELEMENTS[5526] = Fluid3D([9118,8851,8290,8650],0); -ELEMENTS[5527] = Fluid3D([9111,9512,9862,9373],0); -ELEMENTS[5528] = Fluid3D([8851,9111,8290,8444],0); -ELEMENTS[5529] = Fluid3D([7495,7667,7043,6904],0); -ELEMENTS[5530] = Fluid3D([7495,7667,6904,7658],0); -ELEMENTS[5531] = Fluid3D([7667,7043,6904,6751],0); -ELEMENTS[5532] = Fluid3D([7043,6904,6751,6269],0); -ELEMENTS[5533] = Fluid3D([6904,6751,6269,6341],0); -ELEMENTS[5534] = Fluid3D([7667,6904,7658,7319],0); -ELEMENTS[5535] = Fluid3D([7667,6904,7319,6751],0); -ELEMENTS[5536] = Fluid3D([6904,6751,6341,7319],0); -ELEMENTS[5537] = Fluid3D([7043,6904,6269,6531],0); -ELEMENTS[5538] = Fluid3D([6904,6269,6531,6018],0); -ELEMENTS[5539] = Fluid3D([6269,6531,6018,5838],0); -ELEMENTS[5540] = Fluid3D([7043,6904,6531,7495],0); -ELEMENTS[5541] = Fluid3D([6269,6531,5838,6270],0); -ELEMENTS[5542] = Fluid3D([6269,6531,6270,7043],0); -ELEMENTS[5543] = Fluid3D([5838,6269,6270,5688],0); -ELEMENTS[5544] = Fluid3D([6270,5838,5688,5643],0); -ELEMENTS[5545] = Fluid3D([6270,5838,5643,6084],0); -ELEMENTS[5546] = Fluid3D([6270,5838,6084,6531],0); -ELEMENTS[5547] = Fluid3D([5838,6269,5688,5639],0); -ELEMENTS[5548] = Fluid3D([5838,6269,5639,6018],0); -ELEMENTS[5549] = Fluid3D([5688,5838,5639,5238],0); -ELEMENTS[5550] = Fluid3D([5838,5639,5238,5304],0); -ELEMENTS[5551] = Fluid3D([5838,5639,5304,6018],0); -ELEMENTS[5552] = Fluid3D([5688,5838,5238,5643],0); -ELEMENTS[5553] = Fluid3D([6904,6269,6018,6341],0); -ELEMENTS[5554] = Fluid3D([7667,7043,6751,7692],0); -ELEMENTS[5555] = Fluid3D([6269,5688,5639,5883],0); -ELEMENTS[5556] = Fluid3D([5639,6269,5883,6341],0); -ELEMENTS[5557] = Fluid3D([5688,5639,5883,5301],0); -ELEMENTS[5558] = Fluid3D([5639,5883,5301,5506],0); -ELEMENTS[5559] = Fluid3D([5883,5301,5506,5535],0); -ELEMENTS[5560] = Fluid3D([5883,5301,5535,5685],0); -ELEMENTS[5561] = Fluid3D([5883,5301,5685,5688],0); -ELEMENTS[5562] = Fluid3D([6269,5688,5883,6457],0); -ELEMENTS[5563] = Fluid3D([5883,6269,6457,6751],0); -ELEMENTS[5564] = Fluid3D([6269,5688,6457,6270],0); -ELEMENTS[5565] = Fluid3D([5688,5639,5301,5238],0); -ELEMENTS[5566] = Fluid3D([5639,5883,5506,6341],0); -ELEMENTS[5567] = Fluid3D([5688,5883,6457,5685],0); -ELEMENTS[5568] = Fluid3D([7495,7667,7658,8330],0); -ELEMENTS[5569] = Fluid3D([6904,7495,7658,7031],0); -ELEMENTS[5570] = Fluid3D([7495,7658,7031,7892],0); -ELEMENTS[5571] = Fluid3D([6904,7495,7031,6531],0); -ELEMENTS[5572] = Fluid3D([7658,7031,7892,7579],0); -ELEMENTS[5573] = Fluid3D([7658,7031,7579,6951],0); -ELEMENTS[5574] = Fluid3D([7031,7892,7579,7356],0); -ELEMENTS[5575] = Fluid3D([7658,7031,6951,6904],0); -ELEMENTS[5576] = Fluid3D([7579,7031,7356,6773],0); -ELEMENTS[5577] = Fluid3D([7579,7031,6773,6951],0); -ELEMENTS[5578] = Fluid3D([7356,7579,6773,7597],0); -ELEMENTS[5579] = Fluid3D([6773,7356,7597,6893],0); -ELEMENTS[5580] = Fluid3D([7356,7579,7597,8163],0); -ELEMENTS[5581] = Fluid3D([7356,7579,8163,7892],0); -ELEMENTS[5582] = Fluid3D([6773,7356,6893,6515],0); -ELEMENTS[5583] = Fluid3D([6893,6773,6515,6130],0); -ELEMENTS[5584] = Fluid3D([6893,6773,6130,6600],0); -ELEMENTS[5585] = Fluid3D([6893,6773,6600,7597],0); -ELEMENTS[5586] = Fluid3D([6773,7356,6515,7031],0); -ELEMENTS[5587] = Fluid3D([7031,7892,7356,7105],0); -ELEMENTS[5588] = Fluid3D([7892,7356,7105,8009],0); -ELEMENTS[5589] = Fluid3D([7356,7105,8009,7318],0); -ELEMENTS[5590] = Fluid3D([7356,7105,7318,6515],0); -ELEMENTS[5591] = Fluid3D([7031,7892,7105,7495],0); -ELEMENTS[5592] = Fluid3D([7892,7356,8009,8163],0); -ELEMENTS[5593] = Fluid3D([7892,7658,7579,8404],0); -ELEMENTS[5594] = Fluid3D([7658,7579,8404,7839],0); -ELEMENTS[5595] = Fluid3D([7892,7658,8404,8330],0); -ELEMENTS[5596] = Fluid3D([8404,7658,7839,8492],0); -ELEMENTS[5597] = Fluid3D([7579,7892,8404,8163],0); -ELEMENTS[5598] = Fluid3D([7658,7579,7839,6951],0); -ELEMENTS[5599] = Fluid3D([7356,7031,7105,6515],0); -ELEMENTS[5600] = Fluid3D([7495,7658,7892,8330],0); -ELEMENTS[5601] = Fluid3D([7579,8404,7839,8224],0); -ELEMENTS[5602] = Fluid3D([7579,8404,8224,8163],0); -ELEMENTS[5603] = Fluid3D([8404,7839,8224,8776],0); -ELEMENTS[5604] = Fluid3D([8224,8404,8776,9104],0); -ELEMENTS[5605] = Fluid3D([8776,8224,9104,9021],0); -ELEMENTS[5606] = Fluid3D([9104,8776,9021,9804],0); -ELEMENTS[5607] = Fluid3D([9104,8776,9804,9372],0); -ELEMENTS[5608] = Fluid3D([9104,8776,9372,8404],0); -ELEMENTS[5609] = Fluid3D([8404,7839,8776,8492],0); -ELEMENTS[5610] = Fluid3D([8224,8404,9104,8163],0); -ELEMENTS[5611] = Fluid3D([8776,8224,9021,8256],0); -ELEMENTS[5612] = Fluid3D([8776,8224,8256,7839],0); -ELEMENTS[5613] = Fluid3D([8224,9021,8256,8233],0); -ELEMENTS[5614] = Fluid3D([8224,9021,8233,8751],0); -ELEMENTS[5615] = Fluid3D([8233,8224,8751,7777],0); -ELEMENTS[5616] = Fluid3D([8233,8224,7777,7511],0); -ELEMENTS[5617] = Fluid3D([8233,8224,7511,8256],0); -ELEMENTS[5618] = Fluid3D([8224,9021,8751,9104],0); -ELEMENTS[5619] = Fluid3D([9021,8776,8256,9140],0); -ELEMENTS[5620] = Fluid3D([9021,8776,9140,9804],0); -ELEMENTS[5621] = Fluid3D([8776,8256,9140,8840],0); -ELEMENTS[5622] = Fluid3D([8256,9021,9140,8841],0); -ELEMENTS[5623] = Fluid3D([8256,9021,8841,8233],0); -ELEMENTS[5624] = Fluid3D([9021,9140,8841,9771],0); -ELEMENTS[5625] = Fluid3D([9021,9140,9771,9804],0); -ELEMENTS[5626] = Fluid3D([9140,8256,8841,8471],0); -ELEMENTS[5627] = Fluid3D([8256,8841,8471,7928],0); -ELEMENTS[5628] = Fluid3D([9140,8256,8471,8840],0); -ELEMENTS[5629] = Fluid3D([8471,8256,7928,7950],0); -ELEMENTS[5630] = Fluid3D([8471,8256,7950,8840],0); -ELEMENTS[5631] = Fluid3D([8841,9021,9771,9268],0); -ELEMENTS[5632] = Fluid3D([8841,9021,9268,8233],0); -ELEMENTS[5633] = Fluid3D([9021,9771,9268,9934],0); -ELEMENTS[5634] = Fluid3D([9771,8841,9268,9583],0); -ELEMENTS[5635] = Fluid3D([9771,8841,9583,9506],0); -ELEMENTS[5636] = Fluid3D([9771,8841,9506,9140],0); -ELEMENTS[5637] = Fluid3D([9771,9268,9934,10214],0); -ELEMENTS[5638] = Fluid3D([9771,9268,10214,9583],0); -ELEMENTS[5639] = Fluid3D([9934,9771,10214,10452],0); -ELEMENTS[5640] = Fluid3D([9771,10214,10452,10862],0); -ELEMENTS[5641] = Fluid3D([9934,9771,10452,9804],0); -ELEMENTS[5642] = Fluid3D([8256,8841,7928,8233],0); -ELEMENTS[5643] = Fluid3D([9021,9771,9934,9804],0); -ELEMENTS[5644] = Fluid3D([9268,9934,10214,9695],0); -ELEMENTS[5645] = Fluid3D([9934,10214,9695,10754],0); -ELEMENTS[5646] = Fluid3D([10214,9268,9695,9747],0); -ELEMENTS[5647] = Fluid3D([10214,9268,9747,9583],0); -ELEMENTS[5648] = Fluid3D([9268,9695,9747,9001],0); -ELEMENTS[5649] = Fluid3D([9268,9934,9695,8751],0); -ELEMENTS[5650] = Fluid3D([9747,9268,9001,8822],0); -ELEMENTS[5651] = Fluid3D([9268,9001,8822,8233],0); -ELEMENTS[5652] = Fluid3D([9268,9695,9001,8751],0); -ELEMENTS[5653] = Fluid3D([9747,9268,8822,9583],0); -ELEMENTS[5654] = Fluid3D([9695,9747,9001,9796],0); -ELEMENTS[5655] = Fluid3D([9695,9747,9796,10631],0); -ELEMENTS[5656] = Fluid3D([9747,9796,10631,10233],0); -ELEMENTS[5657] = Fluid3D([9747,9796,10233,9231],0); -ELEMENTS[5658] = Fluid3D([9747,9796,9231,9001],0); -ELEMENTS[5659] = Fluid3D([9695,9747,10631,10214],0); -ELEMENTS[5660] = Fluid3D([9001,9695,9796,9359],0); -ELEMENTS[5661] = Fluid3D([9695,9796,9359,10384],0); -ELEMENTS[5662] = Fluid3D([9359,9695,10384,9886],0); -ELEMENTS[5663] = Fluid3D([9359,9695,9886,8751],0); -ELEMENTS[5664] = Fluid3D([9001,9695,9359,8751],0); -ELEMENTS[5665] = Fluid3D([9695,9796,10384,10631],0); -ELEMENTS[5666] = Fluid3D([9796,9001,9359,8917],0); -ELEMENTS[5667] = Fluid3D([9001,9359,8917,8417],0); -ELEMENTS[5668] = Fluid3D([9359,8917,8417,8804],0); -ELEMENTS[5669] = Fluid3D([9359,8917,8804,9664],0); -ELEMENTS[5670] = Fluid3D([9359,8917,9664,9796],0); -ELEMENTS[5671] = Fluid3D([9796,9001,8917,9231],0); -ELEMENTS[5672] = Fluid3D([9001,9359,8417,8751],0); -ELEMENTS[5673] = Fluid3D([9796,9359,10384,9664],0); -ELEMENTS[5674] = Fluid3D([8841,9140,8471,9506],0); -ELEMENTS[5675] = Fluid3D([9021,8233,8751,9268],0); -ELEMENTS[5676] = Fluid3D([7839,7579,8224,7511],0); -ELEMENTS[5677] = Fluid3D([5301,5639,5506,5046],0); -ELEMENTS[5678] = Fluid3D([5506,5301,5046,4943],0); -ELEMENTS[5679] = Fluid3D([5301,5639,5046,5238],0); -ELEMENTS[5680] = Fluid3D([5301,5046,4943,4705],0); -ELEMENTS[5681] = Fluid3D([4943,5301,4705,4930],0); -ELEMENTS[5682] = Fluid3D([4705,4943,4930,4448],0); -ELEMENTS[5683] = Fluid3D([5301,5046,4705,5238],0); -ELEMENTS[5684] = Fluid3D([4705,4943,4448,4461],0); -ELEMENTS[5685] = Fluid3D([4943,4448,4461,4518],0); -ELEMENTS[5686] = Fluid3D([4705,4943,4461,5046],0); -ELEMENTS[5687] = Fluid3D([4943,4448,4518,4794],0); -ELEMENTS[5688] = Fluid3D([4943,4448,4794,4930],0); -ELEMENTS[5689] = Fluid3D([4518,4943,4794,5097],0); -ELEMENTS[5690] = Fluid3D([4943,4794,5097,5535],0); -ELEMENTS[5691] = Fluid3D([4518,4943,5097,4924],0); -ELEMENTS[5692] = Fluid3D([4943,5097,4924,5506],0); -ELEMENTS[5693] = Fluid3D([4518,4943,4924,4461],0); -ELEMENTS[5694] = Fluid3D([4943,5301,4930,5535],0); -ELEMENTS[5695] = Fluid3D([4448,4518,4794,4242],0); -ELEMENTS[5696] = Fluid3D([4448,4518,4242,4030],0); -ELEMENTS[5697] = Fluid3D([4242,4448,4030,3956],0); -ELEMENTS[5698] = Fluid3D([4242,4448,3956,4425],0); -ELEMENTS[5699] = Fluid3D([4242,4448,4425,4794],0); -ELEMENTS[5700] = Fluid3D([4518,4794,4242,4612],0); -ELEMENTS[5701] = Fluid3D([4518,4794,4612,5097],0); -ELEMENTS[5702] = Fluid3D([4242,4518,4612,4175],0); -ELEMENTS[5703] = Fluid3D([4518,4612,4175,4727],0); -ELEMENTS[5704] = Fluid3D([4518,4612,4727,5097],0); -ELEMENTS[5705] = Fluid3D([4242,4518,4175,4030],0); -ELEMENTS[5706] = Fluid3D([4794,4242,4612,4587],0); -ELEMENTS[5707] = Fluid3D([4242,4612,4587,4171],0); -ELEMENTS[5708] = Fluid3D([4612,4587,4171,4656],0); -ELEMENTS[5709] = Fluid3D([4794,4242,4587,4425],0); -ELEMENTS[5710] = Fluid3D([4612,4587,4656,5099],0); -ELEMENTS[5711] = Fluid3D([4587,4656,5099,4997],0); -ELEMENTS[5712] = Fluid3D([4587,4656,4997,4384],0); -ELEMENTS[5713] = Fluid3D([4612,4587,5099,4794],0); -ELEMENTS[5714] = Fluid3D([4587,4656,4384,4171],0); -ELEMENTS[5715] = Fluid3D([4448,4518,4030,4461],0); -ELEMENTS[5716] = Fluid3D([4242,4612,4171,4175],0); -ELEMENTS[5717] = Fluid3D([5639,5506,5046,5490],0); -ELEMENTS[5718] = Fluid3D([5046,5639,5490,5304],0); -ELEMENTS[5719] = Fluid3D([5506,5046,5490,4924],0); -ELEMENTS[5720] = Fluid3D([5639,5506,5490,6341],0); -ELEMENTS[5721] = Fluid3D([5046,5506,4943,4924],0); -ELEMENTS[5722] = Fluid3D([4656,4612,5099,5009],0); -ELEMENTS[5723] = Fluid3D([4612,5099,5009,5097],0); -ELEMENTS[5724] = Fluid3D([4656,4612,5009,4441],0); -ELEMENTS[5725] = Fluid3D([4656,4612,4441,4171],0); -ELEMENTS[5726] = Fluid3D([5099,4656,5009,5243],0); -ELEMENTS[5727] = Fluid3D([5099,4656,5243,4997],0); -ELEMENTS[5728] = Fluid3D([4656,5009,5243,4854],0); -ELEMENTS[5729] = Fluid3D([5243,4656,4854,4830],0); -ELEMENTS[5730] = Fluid3D([4656,5009,4854,4441],0); -ELEMENTS[5731] = Fluid3D([5243,4656,4830,4997],0); -ELEMENTS[5732] = Fluid3D([5009,5243,4854,5436],0); -ELEMENTS[5733] = Fluid3D([5243,4854,5436,5347],0); -ELEMENTS[5734] = Fluid3D([4854,5436,5347,5157],0); -ELEMENTS[5735] = Fluid3D([4854,5436,5157,5026],0); -ELEMENTS[5736] = Fluid3D([4854,5436,5026,5009],0); -ELEMENTS[5737] = Fluid3D([5009,5243,5436,5621],0); -ELEMENTS[5738] = Fluid3D([5436,5009,5621,5555],0); -ELEMENTS[5739] = Fluid3D([5436,5009,5555,5026],0); -ELEMENTS[5740] = Fluid3D([5009,5243,5621,5099],0); -ELEMENTS[5741] = Fluid3D([5243,4854,5347,4830],0); -ELEMENTS[5742] = Fluid3D([5243,5436,5621,5875],0); -ELEMENTS[5743] = Fluid3D([5436,5621,5875,6047],0); -ELEMENTS[5744] = Fluid3D([5243,5436,5875,5347],0); -ELEMENTS[5745] = Fluid3D([5621,5875,6047,6271],0); -ELEMENTS[5746] = Fluid3D([5621,5875,6271,5803],0); -ELEMENTS[5747] = Fluid3D([5621,5875,5803,5243],0); -ELEMENTS[5748] = Fluid3D([6047,5621,6271,6086],0); -ELEMENTS[5749] = Fluid3D([6271,6047,6086,6749],0); -ELEMENTS[5750] = Fluid3D([6047,5621,6086,5555],0); -ELEMENTS[5751] = Fluid3D([6271,6047,6749,6618],0); -ELEMENTS[5752] = Fluid3D([6047,6749,6618,6638],0); -ELEMENTS[5753] = Fluid3D([6047,6749,6638,6298],0); -ELEMENTS[5754] = Fluid3D([6047,6749,6298,6086],0); -ELEMENTS[5755] = Fluid3D([6271,6047,6618,5875],0); -ELEMENTS[5756] = Fluid3D([5621,6271,6086,5952],0); -ELEMENTS[5757] = Fluid3D([5621,6271,5952,5803],0); -ELEMENTS[5758] = Fluid3D([6086,5621,5952,5508],0); -ELEMENTS[5759] = Fluid3D([5621,5952,5508,5099],0); -ELEMENTS[5760] = Fluid3D([6271,6086,5952,6659],0); -ELEMENTS[5761] = Fluid3D([6271,6086,6659,6749],0); -ELEMENTS[5762] = Fluid3D([6086,5952,6659,6156],0); -ELEMENTS[5763] = Fluid3D([5952,6659,6156,6397],0); -ELEMENTS[5764] = Fluid3D([6086,5952,6156,5508],0); -ELEMENTS[5765] = Fluid3D([5952,6659,6397,6495],0); -ELEMENTS[5766] = Fluid3D([6659,6397,6495,7180],0); -ELEMENTS[5767] = Fluid3D([5952,6659,6495,6271],0); -ELEMENTS[5768] = Fluid3D([6659,6397,7180,7005],0); -ELEMENTS[5769] = Fluid3D([6397,7180,7005,7062],0); -ELEMENTS[5770] = Fluid3D([6659,6397,7005,6156],0); -ELEMENTS[5771] = Fluid3D([6397,7180,7062,6788],0); -ELEMENTS[5772] = Fluid3D([6397,7180,6788,6495],0); -ELEMENTS[5773] = Fluid3D([7062,6397,6788,6314],0); -ELEMENTS[5774] = Fluid3D([6397,6788,6314,6005],0); -ELEMENTS[5775] = Fluid3D([7062,6397,6314,6411],0); -ELEMENTS[5776] = Fluid3D([6397,6788,6005,6495],0); -ELEMENTS[5777] = Fluid3D([7062,6397,6411,7005],0); -ELEMENTS[5778] = Fluid3D([6086,5621,5508,5555],0); -ELEMENTS[5779] = Fluid3D([5436,5621,6047,5555],0); -ELEMENTS[5780] = Fluid3D([5875,6271,5803,6367],0); -ELEMENTS[5781] = Fluid3D([6271,5803,6367,6495],0); -ELEMENTS[5782] = Fluid3D([5875,6271,6367,6618],0); -ELEMENTS[5783] = Fluid3D([5803,5875,6367,5753],0); -ELEMENTS[5784] = Fluid3D([5803,5875,5753,5243],0); -ELEMENTS[5785] = Fluid3D([5875,6367,5753,6187],0); -ELEMENTS[5786] = Fluid3D([5875,6367,6187,6618],0); -ELEMENTS[5787] = Fluid3D([5753,5875,6187,5347],0); -ELEMENTS[5788] = Fluid3D([6367,5753,6187,6340],0); -ELEMENTS[5789] = Fluid3D([6187,6367,6340,6952],0); -ELEMENTS[5790] = Fluid3D([5753,6187,6340,5784],0); -ELEMENTS[5791] = Fluid3D([6367,5753,6340,6112],0); -ELEMENTS[5792] = Fluid3D([5753,6187,5784,5347],0); -ELEMENTS[5793] = Fluid3D([6367,5753,6112,5803],0); -ELEMENTS[5794] = Fluid3D([6187,6367,6952,6618],0); -ELEMENTS[5795] = Fluid3D([6367,6340,6952,6950],0); -ELEMENTS[5796] = Fluid3D([6952,6367,6950,7181],0); -ELEMENTS[5797] = Fluid3D([6367,6340,6950,6112],0); -ELEMENTS[5798] = Fluid3D([6367,6950,7181,6495],0); -ELEMENTS[5799] = Fluid3D([6340,6952,6950,7121],0); -ELEMENTS[5800] = Fluid3D([6952,6950,7121,7856],0); -ELEMENTS[5801] = Fluid3D([6340,6952,7121,6652],0); -ELEMENTS[5802] = Fluid3D([6340,6952,6652,6187],0); -ELEMENTS[5803] = Fluid3D([6950,6340,7121,6657],0); -ELEMENTS[5804] = Fluid3D([7121,6950,6657,7519],0); -ELEMENTS[5805] = Fluid3D([7121,6950,7519,7856],0); -ELEMENTS[5806] = Fluid3D([6950,6340,6657,6112],0); -ELEMENTS[5807] = Fluid3D([6952,6950,7856,7181],0); -ELEMENTS[5808] = Fluid3D([6952,6367,7181,6618],0); -ELEMENTS[5809] = Fluid3D([6397,5952,6495,6005],0); -ELEMENTS[5810] = Fluid3D([4612,5009,4441,4727],0); -ELEMENTS[5811] = Fluid3D([5506,5301,4943,5535],0); -ELEMENTS[5812] = Fluid3D([5301,4705,4930,5007],0); -ELEMENTS[5813] = Fluid3D([5301,4705,5007,5238],0); -ELEMENTS[5814] = Fluid3D([4705,4930,5007,4468],0); -ELEMENTS[5815] = Fluid3D([4705,4930,4468,4448],0); -ELEMENTS[5816] = Fluid3D([5007,4705,4468,4537],0); -ELEMENTS[5817] = Fluid3D([4705,4468,4537,4144],0); -ELEMENTS[5818] = Fluid3D([4468,4537,4144,4086],0); -ELEMENTS[5819] = Fluid3D([5007,4705,4537,5238],0); -ELEMENTS[5820] = Fluid3D([4144,4468,4086,3992],0); -ELEMENTS[5821] = Fluid3D([4144,4468,3992,4448],0); -ELEMENTS[5822] = Fluid3D([4468,4086,3992,4153],0); -ELEMENTS[5823] = Fluid3D([4468,4086,4153,4566],0); -ELEMENTS[5824] = Fluid3D([4468,4086,4566,4537],0); -ELEMENTS[5825] = Fluid3D([4086,3992,4153,3719],0); -ELEMENTS[5826] = Fluid3D([4153,4086,3719,4037],0); -ELEMENTS[5827] = Fluid3D([4086,3992,3719,3677],0); -ELEMENTS[5828] = Fluid3D([4086,3992,3677,4144],0); -ELEMENTS[5829] = Fluid3D([4153,4086,4037,4566],0); -ELEMENTS[5830] = Fluid3D([3992,4153,3719,3868],0); -ELEMENTS[5831] = Fluid3D([3992,4153,3868,4425],0); -ELEMENTS[5832] = Fluid3D([3719,3992,3868,3506],0); -ELEMENTS[5833] = Fluid3D([3719,3992,3506,3677],0); -ELEMENTS[5834] = Fluid3D([3992,3868,3506,3956],0); -ELEMENTS[5835] = Fluid3D([3506,3992,3956,3721],0); -ELEMENTS[5836] = Fluid3D([3992,3956,3721,4144],0); -ELEMENTS[5837] = Fluid3D([3721,3992,4144,3677],0); -ELEMENTS[5838] = Fluid3D([3721,3992,3677,3506],0); -ELEMENTS[5839] = Fluid3D([4144,3721,3677,3766],0); -ELEMENTS[5840] = Fluid3D([3721,3677,3766,3365],0); -ELEMENTS[5841] = Fluid3D([3721,3677,3365,3506],0); -ELEMENTS[5842] = Fluid3D([3766,3721,3365,3644],0); -ELEMENTS[5843] = Fluid3D([3766,3721,3644,3994],0); -ELEMENTS[5844] = Fluid3D([3721,3365,3644,3418],0); -ELEMENTS[5845] = Fluid3D([3766,3721,3994,4144],0); -ELEMENTS[5846] = Fluid3D([3721,3365,3418,3506],0); -ELEMENTS[5847] = Fluid3D([3721,3994,4144,4448],0); -ELEMENTS[5848] = Fluid3D([3677,3766,3365,3391],0); -ELEMENTS[5849] = Fluid3D([3365,3677,3391,3206],0); -ELEMENTS[5850] = Fluid3D([3365,3677,3206,3506],0); -ELEMENTS[5851] = Fluid3D([3721,3644,3994,4030],0); -ELEMENTS[5852] = Fluid3D([3644,3721,3418,4030],0); -ELEMENTS[5853] = Fluid3D([3677,3766,3391,3941],0); -ELEMENTS[5854] = Fluid3D([3994,3766,4144,4240],0); -ELEMENTS[5855] = Fluid3D([4144,3994,4240,4461],0); -ELEMENTS[5856] = Fluid3D([3677,3391,3206,3617],0); -ELEMENTS[5857] = Fluid3D([3391,3677,3941,3617],0); -ELEMENTS[5858] = Fluid3D([3677,3766,3941,4144],0); -ELEMENTS[5859] = Fluid3D([3206,3677,3617,3719],0); -ELEMENTS[5860] = Fluid3D([3365,3766,3644,3260],0); -ELEMENTS[5861] = Fluid3D([3766,3644,3260,3799],0); -ELEMENTS[5862] = Fluid3D([3766,3644,3799,3994],0); -ELEMENTS[5863] = Fluid3D([3994,3721,4030,4448],0); -ELEMENTS[5864] = Fluid3D([3994,3766,4240,3799],0); -ELEMENTS[5865] = Fluid3D([3365,3644,3418,3190],0); -ELEMENTS[5866] = Fluid3D([3418,3365,3190,3060],0); -ELEMENTS[5867] = Fluid3D([3365,3644,3190,3260],0); -ELEMENTS[5868] = Fluid3D([3644,3418,3190,3353],0); -ELEMENTS[5869] = Fluid3D([3418,3190,3353,3007],0); -ELEMENTS[5870] = Fluid3D([3418,3190,3007,3060],0); -ELEMENTS[5871] = Fluid3D([3418,3365,3060,3506],0); -ELEMENTS[5872] = Fluid3D([3644,3260,3799,3273],0); -ELEMENTS[5873] = Fluid3D([3644,3260,3273,3190],0); -ELEMENTS[5874] = Fluid3D([3799,3644,3273,3800],0); -ELEMENTS[5875] = Fluid3D([3799,3644,3800,3994],0); -ELEMENTS[5876] = Fluid3D([3365,3190,3060,3088],0); -ELEMENTS[5877] = Fluid3D([3365,3190,3088,3260],0); -ELEMENTS[5878] = Fluid3D([3060,3365,3088,3206],0); -ELEMENTS[5879] = Fluid3D([3766,3391,3941,3741],0); -ELEMENTS[5880] = Fluid3D([3941,3766,3741,4240],0); -ELEMENTS[5881] = Fluid3D([3391,3365,3206,3088],0); -ELEMENTS[5882] = Fluid3D([3391,3206,3617,3237],0); -ELEMENTS[5883] = Fluid3D([3617,3391,3237,3622],0); -ELEMENTS[5884] = Fluid3D([3617,3391,3622,3941],0); -ELEMENTS[5885] = Fluid3D([3644,3418,3353,4030],0); -ELEMENTS[5886] = Fluid3D([3766,3365,3391,3260],0); -ELEMENTS[5887] = Fluid3D([3994,4240,4461,4199],0); -ELEMENTS[5888] = Fluid3D([4461,3994,4199,4075],0); -ELEMENTS[5889] = Fluid3D([4461,3994,4075,4030],0); -ELEMENTS[5890] = Fluid3D([3994,4075,4030,3644],0); -ELEMENTS[5891] = Fluid3D([4461,3994,4030,4448],0); -ELEMENTS[5892] = Fluid3D([4075,4461,4030,4518],0); -ELEMENTS[5893] = Fluid3D([4030,4075,4518,4175],0); -ELEMENTS[5894] = Fluid3D([3994,4199,4075,3800],0); -ELEMENTS[5895] = Fluid3D([4199,4075,3800,4229],0); -ELEMENTS[5896] = Fluid3D([4075,3800,4229,3910],0); -ELEMENTS[5897] = Fluid3D([4075,3800,3910,3353],0); -ELEMENTS[5898] = Fluid3D([3800,4229,3910,3823],0); -ELEMENTS[5899] = Fluid3D([3800,4199,4229,3949],0); -ELEMENTS[5900] = Fluid3D([3800,4229,3823,3949],0); -ELEMENTS[5901] = Fluid3D([3910,3800,3823,3446],0); -ELEMENTS[5902] = Fluid3D([4229,4075,3910,4388],0); -ELEMENTS[5903] = Fluid3D([3910,3800,3446,3353],0); -ELEMENTS[5904] = Fluid3D([4075,3910,4388,4175],0); -ELEMENTS[5905] = Fluid3D([3800,4199,3949,3799],0); -ELEMENTS[5906] = Fluid3D([3800,4199,3799,3994],0); -ELEMENTS[5907] = Fluid3D([4199,3799,3994,4240],0); -ELEMENTS[5908] = Fluid3D([4229,4075,4388,4924],0); -ELEMENTS[5909] = Fluid3D([4199,3949,3799,4159],0); -ELEMENTS[5910] = Fluid3D([3799,4199,4159,4240],0); -ELEMENTS[5911] = Fluid3D([3800,3823,3446,3273],0); -ELEMENTS[5912] = Fluid3D([3823,3800,3949,3273],0); -ELEMENTS[5913] = Fluid3D([4199,4075,4229,4539],0); -ELEMENTS[5914] = Fluid3D([4075,4229,4539,4924],0); -ELEMENTS[5915] = Fluid3D([3910,4229,4388,4185],0); -ELEMENTS[5916] = Fluid3D([4388,3910,4185,3919],0); -ELEMENTS[5917] = Fluid3D([4185,4388,3919,4631],0); -ELEMENTS[5918] = Fluid3D([4199,4461,4075,4539],0); -ELEMENTS[5919] = Fluid3D([4461,4075,4539,4924],0); -ELEMENTS[5920] = Fluid3D([4539,4461,4924,5046],0); -ELEMENTS[5921] = Fluid3D([4199,4461,4539,5046],0); -ELEMENTS[5922] = Fluid3D([4388,3910,3919,4175],0); -ELEMENTS[5923] = Fluid3D([4229,4388,4185,4660],0); -ELEMENTS[5924] = Fluid3D([4229,4388,4660,4812],0); -ELEMENTS[5925] = Fluid3D([4388,4660,4812,4994],0); -ELEMENTS[5926] = Fluid3D([4660,4812,4994,5209],0); -ELEMENTS[5927] = Fluid3D([4660,4812,5209,4809],0); -ELEMENTS[5928] = Fluid3D([4660,4812,4809,4229],0); -ELEMENTS[5929] = Fluid3D([5209,4660,4809,4855],0); -ELEMENTS[5930] = Fluid3D([4994,4660,5209,4947],0); -ELEMENTS[5931] = Fluid3D([4812,5209,4809,5273],0); -ELEMENTS[5932] = Fluid3D([4994,4660,4947,4631],0); -ELEMENTS[5933] = Fluid3D([4947,4994,4631,5051],0); -ELEMENTS[5934] = Fluid3D([4631,4947,5051,4804],0); -ELEMENTS[5935] = Fluid3D([4631,4947,4804,4419],0); -ELEMENTS[5936] = Fluid3D([4631,4947,4419,4660],0); -ELEMENTS[5937] = Fluid3D([5209,4660,4855,4947],0); -ELEMENTS[5938] = Fluid3D([4660,4855,4947,4419],0); -ELEMENTS[5939] = Fluid3D([4994,4631,5051,4727],0); -ELEMENTS[5940] = Fluid3D([4660,4809,4855,4345],0); -ELEMENTS[5941] = Fluid3D([4855,5209,4947,5408],0); -ELEMENTS[5942] = Fluid3D([4947,4855,5408,4939],0); -ELEMENTS[5943] = Fluid3D([4947,4855,4939,4419],0); -ELEMENTS[5944] = Fluid3D([4660,4809,4345,4229],0); -ELEMENTS[5945] = Fluid3D([4809,4812,5273,4715],0); -ELEMENTS[5946] = Fluid3D([4809,4812,4715,4229],0); -ELEMENTS[5947] = Fluid3D([4812,5209,5273,5368],0); -ELEMENTS[5948] = Fluid3D([4812,5209,5368,4994],0); -ELEMENTS[5949] = Fluid3D([5368,4812,4994,4924],0); -ELEMENTS[5950] = Fluid3D([5368,4812,4924,5273],0); -ELEMENTS[5951] = Fluid3D([4812,4994,4924,4388],0); -ELEMENTS[5952] = Fluid3D([4994,4660,4631,4388],0); -ELEMENTS[5953] = Fluid3D([5051,4631,4804,4613],0); -ELEMENTS[5954] = Fluid3D([4855,4660,4345,4419],0); -ELEMENTS[5955] = Fluid3D([5051,4631,4613,4727],0); -ELEMENTS[5956] = Fluid3D([4804,4631,4419,4165],0); -ELEMENTS[5957] = Fluid3D([4812,5273,4715,4924],0); -ELEMENTS[5958] = Fluid3D([4855,5408,4939,5155],0); -ELEMENTS[5959] = Fluid3D([4631,4804,4613,4165],0); -ELEMENTS[5960] = Fluid3D([4939,4855,5155,4589],0); -ELEMENTS[5961] = Fluid3D([4947,5051,4804,5397],0); -ELEMENTS[5962] = Fluid3D([4631,4419,4165,4185],0); -ELEMENTS[5963] = Fluid3D([4631,4419,4185,4660],0); -ELEMENTS[5964] = Fluid3D([4939,4855,4589,4419],0); -ELEMENTS[5965] = Fluid3D([5408,4947,4939,5397],0); -ELEMENTS[5966] = Fluid3D([4947,4804,4419,4939],0); -ELEMENTS[5967] = Fluid3D([4855,5408,5155,5348],0); -ELEMENTS[5968] = Fluid3D([4947,5051,5397,5694],0); -ELEMENTS[5969] = Fluid3D([4809,4855,4345,4691],0); -ELEMENTS[5970] = Fluid3D([4345,4809,4691,4390],0); -ELEMENTS[5971] = Fluid3D([4345,4809,4390,4229],0); -ELEMENTS[5972] = Fluid3D([5209,5273,5368,5719],0); -ELEMENTS[5973] = Fluid3D([5368,5209,5719,5694],0); -ELEMENTS[5974] = Fluid3D([4855,5408,5348,5209],0); -ELEMENTS[5975] = Fluid3D([5209,4947,5408,5694],0); -ELEMENTS[5976] = Fluid3D([5408,5209,5694,5719],0); -ELEMENTS[5977] = Fluid3D([4947,5408,5694,5397],0); -ELEMENTS[5978] = Fluid3D([5209,4947,5694,4994],0); -ELEMENTS[5979] = Fluid3D([4631,4994,4388,4727],0); -ELEMENTS[5980] = Fluid3D([4994,4388,4727,4924],0); -ELEMENTS[5981] = Fluid3D([4804,4947,5397,4939],0); -ELEMENTS[5982] = Fluid3D([4947,4994,5051,5694],0); -ELEMENTS[5983] = Fluid3D([5273,4809,4715,5059],0); -ELEMENTS[5984] = Fluid3D([4809,4715,5059,4390],0); -ELEMENTS[5985] = Fluid3D([5209,5368,4994,5694],0); -ELEMENTS[5986] = Fluid3D([4809,5209,4855,5348],0); -ELEMENTS[5987] = Fluid3D([4804,5051,4613,5149],0); -ELEMENTS[5988] = Fluid3D([5051,5397,5694,5704],0); -ELEMENTS[5989] = Fluid3D([4715,5273,5059,5211],0); -ELEMENTS[5990] = Fluid3D([5059,4715,5211,4839],0); -ELEMENTS[5991] = Fluid3D([5059,4715,4839,4390],0); -ELEMENTS[5992] = Fluid3D([5051,5397,5704,5149],0); -ELEMENTS[5993] = Fluid3D([4804,5051,5149,5397],0); -ELEMENTS[5994] = Fluid3D([5209,4809,5273,5348],0); -ELEMENTS[5995] = Fluid3D([4809,4691,4390,5059],0); -ELEMENTS[5996] = Fluid3D([5155,4939,4589,4937],0); -ELEMENTS[5997] = Fluid3D([4939,4589,4937,4477],0); -ELEMENTS[5998] = Fluid3D([5155,4939,4937,5486],0); -ELEMENTS[5999] = Fluid3D([5155,4939,5486,5408],0); -ELEMENTS[6000] = Fluid3D([4939,4937,5486,5065],0); -ELEMENTS[6001] = Fluid3D([4939,4937,5065,4477],0); -ELEMENTS[6002] = Fluid3D([4939,4589,4477,4419],0); -ELEMENTS[6003] = Fluid3D([4809,4855,4691,5348],0); -ELEMENTS[6004] = Fluid3D([4613,4804,5149,4284],0); -ELEMENTS[6005] = Fluid3D([4388,4631,4727,3919],0); -ELEMENTS[6006] = Fluid3D([4994,5368,4924,5097],0); -ELEMENTS[6007] = Fluid3D([5209,5273,5719,5348],0); -ELEMENTS[6008] = Fluid3D([5408,5155,5348,5798],0); -ELEMENTS[6009] = Fluid3D([5348,5408,5798,5978],0); -ELEMENTS[6010] = Fluid3D([5408,5155,5798,5486],0); -ELEMENTS[6011] = Fluid3D([5348,5408,5978,5719],0); -ELEMENTS[6012] = Fluid3D([5408,5798,5978,5924],0); -ELEMENTS[6013] = Fluid3D([5408,5798,5924,5486],0); -ELEMENTS[6014] = Fluid3D([5273,4809,5059,5348],0); -ELEMENTS[6015] = Fluid3D([5051,4613,5149,5300],0); -ELEMENTS[6016] = Fluid3D([5051,4613,5300,4959],0); -ELEMENTS[6017] = Fluid3D([4613,5300,4959,5026],0); -ELEMENTS[6018] = Fluid3D([5300,4959,5026,5555],0); -ELEMENTS[6019] = Fluid3D([5026,5300,5555,5436],0); -ELEMENTS[6020] = Fluid3D([5300,4959,5555,5051],0); -ELEMENTS[6021] = Fluid3D([4613,5300,5026,4973],0); -ELEMENTS[6022] = Fluid3D([5300,5026,4973,5451],0); -ELEMENTS[6023] = Fluid3D([5300,5026,5451,5436],0); -ELEMENTS[6024] = Fluid3D([4973,5300,5451,5553],0); -ELEMENTS[6025] = Fluid3D([4973,5300,5553,5149],0); -ELEMENTS[6026] = Fluid3D([5300,5553,5149,5704],0); -ELEMENTS[6027] = Fluid3D([5553,4973,5149,5203],0); -ELEMENTS[6028] = Fluid3D([5149,5553,5203,5558],0); -ELEMENTS[6029] = Fluid3D([5149,5553,5558,5704],0); -ELEMENTS[6030] = Fluid3D([5300,5451,5553,5842],0); -ELEMENTS[6031] = Fluid3D([5300,5451,5842,5436],0); -ELEMENTS[6032] = Fluid3D([4973,5300,5149,4613],0); -ELEMENTS[6033] = Fluid3D([5553,5203,5558,5844],0); -ELEMENTS[6034] = Fluid3D([5203,5149,5558,5135],0); -ELEMENTS[6035] = Fluid3D([5558,5553,5844,6163],0); -ELEMENTS[6036] = Fluid3D([5149,5558,5135,5397],0); -ELEMENTS[6037] = Fluid3D([5553,5300,5842,5704],0); -ELEMENTS[6038] = Fluid3D([5558,5553,6163,5704],0); -ELEMENTS[6039] = Fluid3D([5553,5203,5844,5431],0); -ELEMENTS[6040] = Fluid3D([5553,5203,5431,4973],0); -ELEMENTS[6041] = Fluid3D([5203,5149,5135,4796],0); -ELEMENTS[6042] = Fluid3D([5135,5203,4796,5371],0); -ELEMENTS[6043] = Fluid3D([5203,4796,5371,5062],0); -ELEMENTS[6044] = Fluid3D([5203,4796,5062,4973],0); -ELEMENTS[6045] = Fluid3D([5371,5203,5062,5844],0); -ELEMENTS[6046] = Fluid3D([5844,5553,5431,6039],0); -ELEMENTS[6047] = Fluid3D([5026,4973,5451,5157],0); -ELEMENTS[6048] = Fluid3D([5451,5026,5157,5436],0); -ELEMENTS[6049] = Fluid3D([5157,5451,5436,5806],0); -ELEMENTS[6050] = Fluid3D([5157,5451,5806,5664],0); -ELEMENTS[6051] = Fluid3D([5157,5451,5664,4973],0); -ELEMENTS[6052] = Fluid3D([5806,5157,5664,5474],0); -ELEMENTS[6053] = Fluid3D([5806,5157,5474,5347],0); -ELEMENTS[6054] = Fluid3D([5157,5664,5474,5061],0); -ELEMENTS[6055] = Fluid3D([5157,5664,5061,4762],0); -ELEMENTS[6056] = Fluid3D([4973,5149,5203,4796],0); -ELEMENTS[6057] = Fluid3D([5451,5806,5664,6039],0); -ELEMENTS[6058] = Fluid3D([5474,5157,5061,4912],0); -ELEMENTS[6059] = Fluid3D([5474,5157,4912,5347],0); -ELEMENTS[6060] = Fluid3D([5553,5844,6163,6039],0); -ELEMENTS[6061] = Fluid3D([5553,5431,6039,5451],0); -ELEMENTS[6062] = Fluid3D([5203,5558,5844,5371],0); -ELEMENTS[6063] = Fluid3D([5431,5844,6039,5997],0); -ELEMENTS[6064] = Fluid3D([5844,6039,5997,6523],0); -ELEMENTS[6065] = Fluid3D([5844,6039,6523,6163],0); -ELEMENTS[6066] = Fluid3D([5061,5474,4912,4784],0); -ELEMENTS[6067] = Fluid3D([5149,5051,5300,5704],0); -ELEMENTS[6068] = Fluid3D([5844,5558,6163,6190],0); -ELEMENTS[6069] = Fluid3D([5558,6163,6190,6170],0); -ELEMENTS[6070] = Fluid3D([5558,6163,6170,5704],0); -ELEMENTS[6071] = Fluid3D([5844,5558,6190,5371],0); -ELEMENTS[6072] = Fluid3D([6190,5558,6170,5811],0); -ELEMENTS[6073] = Fluid3D([6190,5558,5811,5653],0); -ELEMENTS[6074] = Fluid3D([6190,5558,5653,5371],0); -ELEMENTS[6075] = Fluid3D([5558,5653,5371,5122],0); -ELEMENTS[6076] = Fluid3D([5653,5371,5122,5712],0); -ELEMENTS[6077] = Fluid3D([5653,5371,5712,5981],0); -ELEMENTS[6078] = Fluid3D([5122,5653,5712,5811],0); -ELEMENTS[6079] = Fluid3D([5653,5371,5981,6190],0); -ELEMENTS[6080] = Fluid3D([5712,5653,5981,6190],0); -ELEMENTS[6081] = Fluid3D([5653,5712,5811,6190],0); -ELEMENTS[6082] = Fluid3D([5558,6170,5811,5473],0); -ELEMENTS[6083] = Fluid3D([5558,6170,5473,5704],0); -ELEMENTS[6084] = Fluid3D([5451,4973,5553,5431],0); -ELEMENTS[6085] = Fluid3D([6163,6190,6170,6855],0); -ELEMENTS[6086] = Fluid3D([6170,6163,6855,6527],0); -ELEMENTS[6087] = Fluid3D([6163,6190,6855,6523],0); -ELEMENTS[6088] = Fluid3D([6170,6163,6527,5704],0); -ELEMENTS[6089] = Fluid3D([5664,5806,5474,6179],0); -ELEMENTS[6090] = Fluid3D([5806,5474,6179,6062],0); -ELEMENTS[6091] = Fluid3D([5474,5664,6179,5552],0); -ELEMENTS[6092] = Fluid3D([5474,5664,5552,5061],0); -ELEMENTS[6093] = Fluid3D([6179,5474,5552,5944],0); -ELEMENTS[6094] = Fluid3D([6179,5474,5944,6062],0); -ELEMENTS[6095] = Fluid3D([5806,5474,6062,5347],0); -ELEMENTS[6096] = Fluid3D([5051,4613,4959,4727],0); -ELEMENTS[6097] = Fluid3D([5558,5203,5135,5371],0); -ELEMENTS[6098] = Fluid3D([5436,5157,5806,5347],0); -ELEMENTS[6099] = Fluid3D([5451,5553,5842,6039],0); -ELEMENTS[6100] = Fluid3D([5203,5844,5431,5062],0); -ELEMENTS[6101] = Fluid3D([5431,5203,5062,4973],0); -ELEMENTS[6102] = Fluid3D([5157,5061,4912,4593],0); -ELEMENTS[6103] = Fluid3D([5157,5061,4593,4762],0); -ELEMENTS[6104] = Fluid3D([4912,5157,4593,4854],0); -ELEMENTS[6105] = Fluid3D([5061,4912,4593,4504],0); -ELEMENTS[6106] = Fluid3D([4593,5061,4504,4762],0); -ELEMENTS[6107] = Fluid3D([5061,4504,4762,5056],0); -ELEMENTS[6108] = Fluid3D([5061,4504,5056,4784],0); -ELEMENTS[6109] = Fluid3D([4762,5061,5056,5664],0); -ELEMENTS[6110] = Fluid3D([5061,5056,5664,5552],0); -ELEMENTS[6111] = Fluid3D([5061,5056,5552,4784],0); -ELEMENTS[6112] = Fluid3D([4419,4804,4165,4060],0); -ELEMENTS[6113] = Fluid3D([4075,3994,3800,3644],0); -ELEMENTS[6114] = Fluid3D([3823,3910,3446,3603],0); -ELEMENTS[6115] = Fluid3D([3910,3446,3603,3527],0); -ELEMENTS[6116] = Fluid3D([3910,3446,3527,3353],0); -ELEMENTS[6117] = Fluid3D([3823,3910,3603,4185],0); -ELEMENTS[6118] = Fluid3D([3603,3910,3527,3919],0); -ELEMENTS[6119] = Fluid3D([3446,3603,3527,3040],0); -ELEMENTS[6120] = Fluid3D([4691,4345,4390,4141],0); -ELEMENTS[6121] = Fluid3D([4345,4390,4141,3949],0); -ELEMENTS[6122] = Fluid3D([4691,4345,4141,4589],0); -ELEMENTS[6123] = Fluid3D([4855,5155,4589,4691],0); -ELEMENTS[6124] = Fluid3D([4229,3910,3823,4185],0); -ELEMENTS[6125] = Fluid3D([5694,5051,5704,5592],0); -ELEMENTS[6126] = Fluid3D([5694,5051,5592,4994],0); -ELEMENTS[6127] = Fluid3D([4855,4345,4691,4589],0); -ELEMENTS[6128] = Fluid3D([5155,4855,5348,4691],0); -ELEMENTS[6129] = Fluid3D([4199,3949,4159,4715],0); -ELEMENTS[6130] = Fluid3D([5273,5368,5719,5490],0); -ELEMENTS[6131] = Fluid3D([5273,5368,5490,4924],0); -ELEMENTS[6132] = Fluid3D([4199,4229,3949,4715],0); -ELEMENTS[6133] = Fluid3D([4229,3823,3949,4345],0); -ELEMENTS[6134] = Fluid3D([4229,4199,4539,4715],0); -ELEMENTS[6135] = Fluid3D([4199,4539,4715,5046],0); -ELEMENTS[6136] = Fluid3D([4388,4185,4660,4631],0); -ELEMENTS[6137] = Fluid3D([4705,4468,4144,4448],0); -ELEMENTS[6138] = Fluid3D([3992,4468,4153,4425],0); -ELEMENTS[6139] = Fluid3D([4930,5301,5007,5685],0); -ELEMENTS[6140] = Fluid3D([4468,5007,4537,4566],0); -ELEMENTS[6141] = Fluid3D([4537,4705,4144,4240],0); -ELEMENTS[6142] = Fluid3D([4930,5007,4468,4832],0); -ELEMENTS[6143] = Fluid3D([5007,4468,4832,4566],0); -ELEMENTS[6144] = Fluid3D([4930,5007,4832,5685],0); -ELEMENTS[6145] = Fluid3D([4468,4930,4832,4425],0); -ELEMENTS[6146] = Fluid3D([11086,11441,10509,11860],0); -ELEMENTS[6147] = Fluid3D([10461,10509,9608,10158],0); -ELEMENTS[6148] = Fluid3D([10461,10509,10158,11395],0); -ELEMENTS[6149] = Fluid3D([10509,9608,10158,9751],0); -ELEMENTS[6150] = Fluid3D([10158,10509,9751,10865],0); -ELEMENTS[6151] = Fluid3D([10158,10509,10865,11395],0); -ELEMENTS[6152] = Fluid3D([9751,10158,10865,10160],0); -ELEMENTS[6153] = Fluid3D([10158,10865,10160,10800],0); -ELEMENTS[6154] = Fluid3D([9751,10158,10160,9362],0); -ELEMENTS[6155] = Fluid3D([10509,9608,9751,9696],0); -ELEMENTS[6156] = Fluid3D([10509,9751,10865,10540],0); -ELEMENTS[6157] = Fluid3D([10865,9751,10160,10235],0); -ELEMENTS[6158] = Fluid3D([10160,10865,10235,11034],0); -ELEMENTS[6159] = Fluid3D([10865,9751,10235,10540],0); -ELEMENTS[6160] = Fluid3D([9751,10160,10235,9337],0); -ELEMENTS[6161] = Fluid3D([10235,9751,9337,9505],0); -ELEMENTS[6162] = Fluid3D([10235,9751,9505,10540],0); -ELEMENTS[6163] = Fluid3D([9751,10160,9337,9362],0); -ELEMENTS[6164] = Fluid3D([10160,10235,9337,10005],0); -ELEMENTS[6165] = Fluid3D([10160,10235,10005,11034],0); -ELEMENTS[6166] = Fluid3D([10235,9337,10005,9569],0); -ELEMENTS[6167] = Fluid3D([9337,10160,10005,9424],0); -ELEMENTS[6168] = Fluid3D([9337,10160,9424,9362],0); -ELEMENTS[6169] = Fluid3D([9337,10005,9569,9040],0); -ELEMENTS[6170] = Fluid3D([9337,10005,9040,9424],0); -ELEMENTS[6171] = Fluid3D([10005,9569,9040,9748],0); -ELEMENTS[6172] = Fluid3D([9569,9040,9748,8854],0); -ELEMENTS[6173] = Fluid3D([10005,9569,9748,10538],0); -ELEMENTS[6174] = Fluid3D([10005,9569,10538,10235],0); -ELEMENTS[6175] = Fluid3D([9569,9040,8854,8641],0); -ELEMENTS[6176] = Fluid3D([9569,9040,8641,9337],0); -ELEMENTS[6177] = Fluid3D([9040,8854,8641,8069],0); -ELEMENTS[6178] = Fluid3D([8854,8641,8069,8096],0); -ELEMENTS[6179] = Fluid3D([8854,8641,8096,8936],0); -ELEMENTS[6180] = Fluid3D([8854,8641,8936,9569],0); -ELEMENTS[6181] = Fluid3D([9040,8854,8069,8800],0); -ELEMENTS[6182] = Fluid3D([8854,8069,8800,8198],0); -ELEMENTS[6183] = Fluid3D([8854,8069,8198,8096],0); -ELEMENTS[6184] = Fluid3D([9040,8854,8800,9748],0); -ELEMENTS[6185] = Fluid3D([10865,10235,11034,11257],0); -ELEMENTS[6186] = Fluid3D([10235,9337,9569,9505],0); -ELEMENTS[6187] = Fluid3D([10160,10865,11034,10800],0); -ELEMENTS[6188] = Fluid3D([9608,10461,10158,9585],0); -ELEMENTS[6189] = Fluid3D([8069,9040,8800,8437],0); -ELEMENTS[6190] = Fluid3D([8800,8069,8437,7907],0); -ELEMENTS[6191] = Fluid3D([8437,8800,7907,8586],0); -ELEMENTS[6192] = Fluid3D([7907,8437,8586,7929],0); -ELEMENTS[6193] = Fluid3D([7907,8437,7929,7550],0); -ELEMENTS[6194] = Fluid3D([7907,8437,7550,8069],0); -ELEMENTS[6195] = Fluid3D([8069,9040,8437,8307],0); -ELEMENTS[6196] = Fluid3D([8069,9040,8307,8641],0); -ELEMENTS[6197] = Fluid3D([9040,8437,8307,8752],0); -ELEMENTS[6198] = Fluid3D([8437,8800,8586,9329],0); -ELEMENTS[6199] = Fluid3D([8800,8586,9329,9390],0); -ELEMENTS[6200] = Fluid3D([8437,8800,9329,9040],0); -ELEMENTS[6201] = Fluid3D([8586,9329,9390,9414],0); -ELEMENTS[6202] = Fluid3D([8586,9329,9414,9384],0); -ELEMENTS[6203] = Fluid3D([9329,9414,9384,10110],0); -ELEMENTS[6204] = Fluid3D([9390,8586,9414,8957],0); -ELEMENTS[6205] = Fluid3D([9390,8586,8957,8533],0); -ELEMENTS[6206] = Fluid3D([9390,8586,8533,8800],0); -ELEMENTS[6207] = Fluid3D([8586,9414,8957,8470],0); -ELEMENTS[6208] = Fluid3D([8586,9414,8470,8796],0); -ELEMENTS[6209] = Fluid3D([8586,9414,8796,9384],0); -ELEMENTS[6210] = Fluid3D([8957,8586,8470,7723],0); -ELEMENTS[6211] = Fluid3D([8957,8586,7723,8533],0); -ELEMENTS[6212] = Fluid3D([9414,8796,9384,8962],0); -ELEMENTS[6213] = Fluid3D([9329,9390,9414,10200],0); -ELEMENTS[6214] = Fluid3D([9329,9390,10200,9748],0); -ELEMENTS[6215] = Fluid3D([9390,9414,10200,10015],0); -ELEMENTS[6216] = Fluid3D([10200,9390,10015,10337],0); -ELEMENTS[6217] = Fluid3D([9390,9414,10015,8957],0); -ELEMENTS[6218] = Fluid3D([10200,9390,10337,9748],0); -ELEMENTS[6219] = Fluid3D([9414,10200,10015,10110],0); -ELEMENTS[6220] = Fluid3D([9414,10200,10110,9329],0); -ELEMENTS[6221] = Fluid3D([9414,8957,8470,9376],0); -ELEMENTS[6222] = Fluid3D([8957,8470,9376,8519],0); -ELEMENTS[6223] = Fluid3D([8470,9376,8519,8723],0); -ELEMENTS[6224] = Fluid3D([8470,9376,8723,9262],0); -ELEMENTS[6225] = Fluid3D([8470,9376,9262,9414],0); -ELEMENTS[6226] = Fluid3D([9414,8957,9376,10015],0); -ELEMENTS[6227] = Fluid3D([8957,8470,8519,7723],0); -ELEMENTS[6228] = Fluid3D([8800,8069,7907,8198],0); -ELEMENTS[6229] = Fluid3D([8437,8069,8307,7550],0); -ELEMENTS[6230] = Fluid3D([8437,8586,7929,8796],0); -ELEMENTS[6231] = Fluid3D([8800,7907,8586,8533],0); -ELEMENTS[6232] = Fluid3D([9608,10158,9751,9227],0); -ELEMENTS[6233] = Fluid3D([10158,9751,9227,9362],0); -ELEMENTS[6234] = Fluid3D([9608,10158,9227,9363],0); -ELEMENTS[6235] = Fluid3D([10158,9227,9363,9362],0); -ELEMENTS[6236] = Fluid3D([9227,9363,9362,8581],0); -ELEMENTS[6237] = Fluid3D([9227,9363,8581,9608],0); -ELEMENTS[6238] = Fluid3D([9362,9227,8581,8769],0); -ELEMENTS[6239] = Fluid3D([9362,9227,8769,9751],0); -ELEMENTS[6240] = Fluid3D([9363,9362,8581,8747],0); -ELEMENTS[6241] = Fluid3D([8581,9363,8747,9608],0); -ELEMENTS[6242] = Fluid3D([9363,9362,8747,9801],0); -ELEMENTS[6243] = Fluid3D([9227,8581,8769,8522],0); -ELEMENTS[6244] = Fluid3D([9227,8581,8522,9608],0); -ELEMENTS[6245] = Fluid3D([8581,9362,8769,8752],0); -ELEMENTS[6246] = Fluid3D([8769,9227,8522,9751],0); -ELEMENTS[6247] = Fluid3D([9362,8769,8752,9424],0); -ELEMENTS[6248] = Fluid3D([8769,8752,9424,9040],0); -ELEMENTS[6249] = Fluid3D([9362,8769,9424,9337],0); -ELEMENTS[6250] = Fluid3D([8769,9424,9337,9040],0); -ELEMENTS[6251] = Fluid3D([8752,9362,9424,9630],0); -ELEMENTS[6252] = Fluid3D([9424,8752,9630,9384],0); -ELEMENTS[6253] = Fluid3D([9362,9424,9630,10160],0); -ELEMENTS[6254] = Fluid3D([8581,8769,8522,7957],0); -ELEMENTS[6255] = Fluid3D([8522,8581,7957,7927],0); -ELEMENTS[6256] = Fluid3D([8522,8581,7927,8809],0); -ELEMENTS[6257] = Fluid3D([8522,8581,8809,9608],0); -ELEMENTS[6258] = Fluid3D([9630,9424,9384,10369],0); -ELEMENTS[6259] = Fluid3D([8581,8769,7957,8752],0); -ELEMENTS[6260] = Fluid3D([8581,7957,7927,7635],0); -ELEMENTS[6261] = Fluid3D([8581,7927,8809,8747],0); -ELEMENTS[6262] = Fluid3D([8809,8581,8747,9608],0); -ELEMENTS[6263] = Fluid3D([8581,7957,7635,8109],0); -ELEMENTS[6264] = Fluid3D([8581,7957,8109,8752],0); -ELEMENTS[6265] = Fluid3D([7927,8581,7635,8747],0); -ELEMENTS[6266] = Fluid3D([7635,8581,8109,8289],0); -ELEMENTS[6267] = Fluid3D([7635,8581,8289,8747],0); -ELEMENTS[6268] = Fluid3D([8581,8289,8747,9362],0); -ELEMENTS[6269] = Fluid3D([8581,8109,8289,8752],0); -ELEMENTS[6270] = Fluid3D([8769,8522,7957,8307],0); -ELEMENTS[6271] = Fluid3D([7957,8769,8307,8752],0); -ELEMENTS[6272] = Fluid3D([8769,8307,8752,9040],0); -ELEMENTS[6273] = Fluid3D([8769,8307,9040,8641],0); -ELEMENTS[6274] = Fluid3D([7957,8522,7927,7785],0); -ELEMENTS[6275] = Fluid3D([7957,8522,7785,8260],0); -ELEMENTS[6276] = Fluid3D([8522,7927,7785,8300],0); -ELEMENTS[6277] = Fluid3D([8522,7927,8300,8809],0); -ELEMENTS[6278] = Fluid3D([8522,7785,8260,8355],0); -ELEMENTS[6279] = Fluid3D([8522,7785,8355,8300],0); -ELEMENTS[6280] = Fluid3D([8260,8522,8355,9505],0); -ELEMENTS[6281] = Fluid3D([7957,8522,8260,8307],0); -ELEMENTS[6282] = Fluid3D([8260,7957,8307,7555],0); -ELEMENTS[6283] = Fluid3D([8307,8260,7555,8069],0); -ELEMENTS[6284] = Fluid3D([7957,8307,7555,7603],0); -ELEMENTS[6285] = Fluid3D([7957,8307,7603,8752],0); -ELEMENTS[6286] = Fluid3D([8307,7555,7603,7550],0); -ELEMENTS[6287] = Fluid3D([7555,7603,7550,6859],0); -ELEMENTS[6288] = Fluid3D([7603,7550,6859,7088],0); -ELEMENTS[6289] = Fluid3D([7603,7550,7088,7929],0); -ELEMENTS[6290] = Fluid3D([7603,8307,7550,8437],0); -ELEMENTS[6291] = Fluid3D([6859,7603,7088,6976],0); -ELEMENTS[6292] = Fluid3D([6859,7603,6976,7202],0); -ELEMENTS[6293] = Fluid3D([7603,7088,6976,7882],0); -ELEMENTS[6294] = Fluid3D([6859,7603,7202,7555],0); -ELEMENTS[6295] = Fluid3D([7603,7202,7555,7957],0); -ELEMENTS[6296] = Fluid3D([7202,7555,7957,7785],0); -ELEMENTS[6297] = Fluid3D([7603,7202,7957,7635],0); -ELEMENTS[6298] = Fluid3D([7550,6859,7088,6890],0); -ELEMENTS[6299] = Fluid3D([7088,7550,6890,7929],0); -ELEMENTS[6300] = Fluid3D([7202,7957,7635,7927],0); -ELEMENTS[6301] = Fluid3D([7202,6859,7555,6755],0); -ELEMENTS[6302] = Fluid3D([7555,7202,6755,7785],0); -ELEMENTS[6303] = Fluid3D([7603,6976,7202,7635],0); -ELEMENTS[6304] = Fluid3D([7550,6859,6890,7041],0); -ELEMENTS[6305] = Fluid3D([7550,6859,7041,7555],0); -ELEMENTS[6306] = Fluid3D([8260,7957,7555,7785],0); -ELEMENTS[6307] = Fluid3D([6890,7550,7041,7907],0); -ELEMENTS[6308] = Fluid3D([7202,6859,6755,6333],0); -ELEMENTS[6309] = Fluid3D([6755,7202,6333,6722],0); -ELEMENTS[6310] = Fluid3D([6755,7202,6722,7785],0); -ELEMENTS[6311] = Fluid3D([7202,6333,6722,6817],0); -ELEMENTS[6312] = Fluid3D([7202,6333,6817,6976],0); -ELEMENTS[6313] = Fluid3D([7088,6859,6976,6297],0); -ELEMENTS[6314] = Fluid3D([6859,6976,6297,6333],0); -ELEMENTS[6315] = Fluid3D([6976,7088,6297,6905],0); -ELEMENTS[6316] = Fluid3D([6976,7088,6905,7882],0); -ELEMENTS[6317] = Fluid3D([6297,6976,6905,6161],0); -ELEMENTS[6318] = Fluid3D([6297,6976,6161,6333],0); -ELEMENTS[6319] = Fluid3D([6859,6890,7041,6250],0); -ELEMENTS[6320] = Fluid3D([7041,6859,6250,6755],0); -ELEMENTS[6321] = Fluid3D([6976,6905,6161,6889],0); -ELEMENTS[6322] = Fluid3D([6976,6905,6889,7882],0); -ELEMENTS[6323] = Fluid3D([7202,6859,6333,6976],0); -ELEMENTS[6324] = Fluid3D([6722,7202,6817,7927],0); -ELEMENTS[6325] = Fluid3D([6333,6755,6722,5990],0); -ELEMENTS[6326] = Fluid3D([6755,6722,5990,6614],0); -ELEMENTS[6327] = Fluid3D([5990,6755,6614,6239],0); -ELEMENTS[6328] = Fluid3D([6755,6722,6614,7785],0); -ELEMENTS[6329] = Fluid3D([7927,7957,7785,7202],0); -ELEMENTS[6330] = Fluid3D([7785,8260,8355,7831],0); -ELEMENTS[6331] = Fluid3D([8260,8355,7831,8641],0); -ELEMENTS[6332] = Fluid3D([7831,8260,8641,7715],0); -ELEMENTS[6333] = Fluid3D([8260,8641,7715,8069],0); -ELEMENTS[6334] = Fluid3D([8641,7715,8069,8096],0); -ELEMENTS[6335] = Fluid3D([7715,8069,8096,7041],0); -ELEMENTS[6336] = Fluid3D([7831,8260,7715,7785],0); -ELEMENTS[6337] = Fluid3D([8260,8641,8069,8307],0); -ELEMENTS[6338] = Fluid3D([8260,8641,8307,8769],0); -ELEMENTS[6339] = Fluid3D([8307,8260,8769,8522],0); -ELEMENTS[6340] = Fluid3D([9337,8769,9040,8641],0); -ELEMENTS[6341] = Fluid3D([7957,7635,8109,7603],0); -ELEMENTS[6342] = Fluid3D([8109,7957,7603,8752],0); -ELEMENTS[6343] = Fluid3D([7603,8109,8752,7882],0); -ELEMENTS[6344] = Fluid3D([8109,8752,7882,8289],0); -ELEMENTS[6345] = Fluid3D([7088,6859,6297,6890],0); -ELEMENTS[6346] = Fluid3D([8109,7635,8289,7882],0); -ELEMENTS[6347] = Fluid3D([7088,6297,6905,6459],0); -ELEMENTS[6348] = Fluid3D([6905,7088,6459,7234],0); -ELEMENTS[6349] = Fluid3D([6459,6905,7234,6467],0); -ELEMENTS[6350] = Fluid3D([6459,6905,6467,5788],0); -ELEMENTS[6351] = Fluid3D([6459,6905,5788,6297],0); -ELEMENTS[6352] = Fluid3D([7088,6297,6459,6890],0); -ELEMENTS[6353] = Fluid3D([6905,7088,7234,7882],0); -ELEMENTS[6354] = Fluid3D([7088,6459,7234,7120],0); -ELEMENTS[6355] = Fluid3D([7234,7088,7120,7929],0); -ELEMENTS[6356] = Fluid3D([7088,6459,7120,6890],0); -ELEMENTS[6357] = Fluid3D([6459,7234,7120,6819],0); -ELEMENTS[6358] = Fluid3D([7234,7120,6819,7895],0); -ELEMENTS[6359] = Fluid3D([7120,6459,6819,6402],0); -ELEMENTS[6360] = Fluid3D([6819,7120,6402,7235],0); -ELEMENTS[6361] = Fluid3D([7120,6459,6402,6890],0); -ELEMENTS[6362] = Fluid3D([6459,7234,6819,6467],0); -ELEMENTS[6363] = Fluid3D([6819,7120,7235,7895],0); -ELEMENTS[6364] = Fluid3D([6459,6819,6402,6035],0); -ELEMENTS[6365] = Fluid3D([6819,6402,6035,6335],0); -ELEMENTS[6366] = Fluid3D([6402,6035,6335,5786],0); -ELEMENTS[6367] = Fluid3D([6402,6035,5786,5813],0); -ELEMENTS[6368] = Fluid3D([6402,6035,5813,6459],0); -ELEMENTS[6369] = Fluid3D([6459,6819,6035,6467],0); -ELEMENTS[6370] = Fluid3D([6819,6402,6335,7235],0); -ELEMENTS[6371] = Fluid3D([6035,5786,5813,5381],0); -ELEMENTS[6372] = Fluid3D([5786,5813,5381,5292],0); -ELEMENTS[6373] = Fluid3D([5813,5381,5292,5213],0); -ELEMENTS[6374] = Fluid3D([5813,5381,5213,5788],0); -ELEMENTS[6375] = Fluid3D([6035,5786,5381,5658],0); -ELEMENTS[6376] = Fluid3D([5786,5381,5658,5186],0); -ELEMENTS[6377] = Fluid3D([5786,5381,5186,5292],0); -ELEMENTS[6378] = Fluid3D([6035,5786,5658,6335],0); -ELEMENTS[6379] = Fluid3D([5786,5813,5292,5892],0); -ELEMENTS[6380] = Fluid3D([5813,5292,5892,5542],0); -ELEMENTS[6381] = Fluid3D([5786,5813,5892,6402],0); -ELEMENTS[6382] = Fluid3D([5292,5786,5892,5498],0); -ELEMENTS[6383] = Fluid3D([5786,5892,5498,6164],0); -ELEMENTS[6384] = Fluid3D([5786,5892,6164,6402],0); -ELEMENTS[6385] = Fluid3D([5292,5786,5498,5186],0); -ELEMENTS[6386] = Fluid3D([5813,5292,5542,5213],0); -ELEMENTS[6387] = Fluid3D([5892,5813,5542,6217],0); -ELEMENTS[6388] = Fluid3D([5813,5542,6217,5835],0); -ELEMENTS[6389] = Fluid3D([5892,5813,6217,6402],0); -ELEMENTS[6390] = Fluid3D([5542,5892,6217,5954],0); -ELEMENTS[6391] = Fluid3D([5892,6217,5954,6530],0); -ELEMENTS[6392] = Fluid3D([5892,6217,6530,6402],0); -ELEMENTS[6393] = Fluid3D([5542,5892,5954,5450],0); -ELEMENTS[6394] = Fluid3D([5892,5954,5450,5947],0); -ELEMENTS[6395] = Fluid3D([5892,5954,5947,6530],0); -ELEMENTS[6396] = Fluid3D([5542,5892,5450,5292],0); -ELEMENTS[6397] = Fluid3D([5813,5542,5835,5213],0); -ELEMENTS[6398] = Fluid3D([5542,6217,5835,6250],0); -ELEMENTS[6399] = Fluid3D([6217,5835,6250,6297],0); -ELEMENTS[6400] = Fluid3D([5813,6035,5381,5788],0); -ELEMENTS[6401] = Fluid3D([9751,9608,9227,8522],0); -ELEMENTS[6402] = Fluid3D([7120,6402,7235,6986],0); -ELEMENTS[6403] = Fluid3D([7235,7120,6986,7723],0); -ELEMENTS[6404] = Fluid3D([6402,7235,6986,6164],0); -ELEMENTS[6405] = Fluid3D([7120,6402,6986,6890],0); -ELEMENTS[6406] = Fluid3D([6035,6819,6335,6348],0); -ELEMENTS[6407] = Fluid3D([6819,6335,6348,7140],0); -ELEMENTS[6408] = Fluid3D([6335,6348,7140,6334],0); -ELEMENTS[6409] = Fluid3D([6348,7140,6334,6818],0); -ELEMENTS[6410] = Fluid3D([6348,7140,6818,7122],0); -ELEMENTS[6411] = Fluid3D([6348,7140,7122,6819],0); -ELEMENTS[6412] = Fluid3D([6035,6819,6348,6467],0); -ELEMENTS[6413] = Fluid3D([6335,6348,6334,5658],0); -ELEMENTS[6414] = Fluid3D([7140,6818,7122,7663],0); -ELEMENTS[6415] = Fluid3D([6818,7122,7663,7375],0); -ELEMENTS[6416] = Fluid3D([7122,7140,7663,7895],0); -ELEMENTS[6417] = Fluid3D([7140,6818,7663,7191],0); -ELEMENTS[6418] = Fluid3D([6818,7663,7191,7422],0); -ELEMENTS[6419] = Fluid3D([6818,7663,7422,7375],0); -ELEMENTS[6420] = Fluid3D([7140,6818,7191,6334],0); -ELEMENTS[6421] = Fluid3D([6818,7122,7375,6562],0); -ELEMENTS[6422] = Fluid3D([6818,7122,6562,6348],0); -ELEMENTS[6423] = Fluid3D([7122,7375,6562,7254],0); -ELEMENTS[6424] = Fluid3D([7375,6562,7254,7007],0); -ELEMENTS[6425] = Fluid3D([7375,6562,7007,6729],0); -ELEMENTS[6426] = Fluid3D([7375,6562,6729,6818],0); -ELEMENTS[6427] = Fluid3D([7254,7375,7007,7845],0); -ELEMENTS[6428] = Fluid3D([7007,7254,7845,7365],0); -ELEMENTS[6429] = Fluid3D([7375,7007,7845,7587],0); -ELEMENTS[6430] = Fluid3D([7375,7007,7587,6729],0); -ELEMENTS[6431] = Fluid3D([7254,7375,7845,7771],0); -ELEMENTS[6432] = Fluid3D([7007,7254,7365,6556],0); -ELEMENTS[6433] = Fluid3D([7365,7007,6556,6719],0); -ELEMENTS[6434] = Fluid3D([7007,7254,6556,6562],0); -ELEMENTS[6435] = Fluid3D([7254,7365,6556,7109],0); -ELEMENTS[6436] = Fluid3D([6556,7254,7109,6715],0); -ELEMENTS[6437] = Fluid3D([6556,7254,6715,6562],0); -ELEMENTS[6438] = Fluid3D([7254,7365,7109,7942],0); -ELEMENTS[6439] = Fluid3D([7365,7109,7942,7712],0); -ELEMENTS[6440] = Fluid3D([7365,7109,7712,6879],0); -ELEMENTS[6441] = Fluid3D([7365,7109,6879,6556],0); -ELEMENTS[6442] = Fluid3D([7254,7365,7942,7845],0); -ELEMENTS[6443] = Fluid3D([7365,7007,6719,7507],0); -ELEMENTS[6444] = Fluid3D([7365,7007,7507,7845],0); -ELEMENTS[6445] = Fluid3D([7007,6719,7507,6793],0); -ELEMENTS[6446] = Fluid3D([7007,6719,6793,6204],0); -ELEMENTS[6447] = Fluid3D([7007,6719,6204,6556],0); -ELEMENTS[6448] = Fluid3D([6719,7365,7507,7392],0); -ELEMENTS[6449] = Fluid3D([7365,7507,7392,8136],0); -ELEMENTS[6450] = Fluid3D([7365,7507,8136,7845],0); -ELEMENTS[6451] = Fluid3D([6719,7365,7392,6879],0); -ELEMENTS[6452] = Fluid3D([6719,7507,6793,6998],0); -ELEMENTS[6453] = Fluid3D([6793,6719,6998,6200],0); -ELEMENTS[6454] = Fluid3D([7507,6793,6998,7519],0); -ELEMENTS[6455] = Fluid3D([6719,7507,6998,7392],0); -ELEMENTS[6456] = Fluid3D([6793,6719,6200,6204],0); -ELEMENTS[6457] = Fluid3D([7122,7375,7254,7771],0); -ELEMENTS[6458] = Fluid3D([7254,7122,7771,6715],0); -ELEMENTS[6459] = Fluid3D([6335,6035,6348,5658],0); -ELEMENTS[6460] = Fluid3D([6562,7122,7254,6715],0); -ELEMENTS[6461] = Fluid3D([7122,7663,7375,7771],0); -ELEMENTS[6462] = Fluid3D([6819,6335,7140,7235],0); -ELEMENTS[6463] = Fluid3D([7927,7785,8300,7406],0); -ELEMENTS[6464] = Fluid3D([8300,7927,7406,7953],0); -ELEMENTS[6465] = Fluid3D([7927,7785,7406,6722],0); -ELEMENTS[6466] = Fluid3D([7406,8300,7953,7858],0); -ELEMENTS[6467] = Fluid3D([8300,7953,7858,8666],0); -ELEMENTS[6468] = Fluid3D([7785,8300,7406,7731],0); -ELEMENTS[6469] = Fluid3D([7785,8300,7731,8355],0); -ELEMENTS[6470] = Fluid3D([7953,7858,8666,8021],0); -ELEMENTS[6471] = Fluid3D([7953,7858,8021,7217],0); -ELEMENTS[6472] = Fluid3D([7953,7858,7217,7406],0); -ELEMENTS[6473] = Fluid3D([7858,8666,8021,8413],0); -ELEMENTS[6474] = Fluid3D([8021,7858,8413,7258],0); -ELEMENTS[6475] = Fluid3D([7858,8666,8413,8622],0); -ELEMENTS[6476] = Fluid3D([8021,7858,7258,7217],0); -ELEMENTS[6477] = Fluid3D([7858,8666,8622,8300],0); -ELEMENTS[6478] = Fluid3D([8300,7953,8666,8809],0); -ELEMENTS[6479] = Fluid3D([7406,8300,7858,7731],0); -ELEMENTS[6480] = Fluid3D([8300,7927,7953,8809],0); -ELEMENTS[6481] = Fluid3D([7927,7406,7953,7157],0); -ELEMENTS[6482] = Fluid3D([7927,7406,7157,6722],0); -ELEMENTS[6483] = Fluid3D([7953,7927,7157,8022],0); -ELEMENTS[6484] = Fluid3D([7953,7927,8022,8809],0); -ELEMENTS[6485] = Fluid3D([7157,7953,8022,7554],0); -ELEMENTS[6486] = Fluid3D([7953,8022,7554,8772],0); -ELEMENTS[6487] = Fluid3D([7406,7953,7157,7217],0); -ELEMENTS[6488] = Fluid3D([7157,7953,7554,7217],0); -ELEMENTS[6489] = Fluid3D([7927,7157,8022,7635],0); -ELEMENTS[6490] = Fluid3D([8022,7157,7554,7264],0); -ELEMENTS[6491] = Fluid3D([7554,8022,7264,7985],0); -ELEMENTS[6492] = Fluid3D([8022,7157,7264,7635],0); -ELEMENTS[6493] = Fluid3D([8022,7264,7985,7971],0); -ELEMENTS[6494] = Fluid3D([8022,7264,7971,7635],0); -ELEMENTS[6495] = Fluid3D([7985,8022,7971,8851],0); -ELEMENTS[6496] = Fluid3D([7157,7554,7264,6694],0); -ELEMENTS[6497] = Fluid3D([7157,7554,6694,7217],0); -ELEMENTS[6498] = Fluid3D([7264,7157,6694,6654],0); -ELEMENTS[6499] = Fluid3D([7264,7157,6654,7635],0); -ELEMENTS[6500] = Fluid3D([7157,6694,6654,6430],0); -ELEMENTS[6501] = Fluid3D([6694,6654,6430,5980],0); -ELEMENTS[6502] = Fluid3D([6694,6654,5980,6375],0); -ELEMENTS[6503] = Fluid3D([6694,6654,6375,7264],0); -ELEMENTS[6504] = Fluid3D([7157,6694,6430,7217],0); -ELEMENTS[6505] = Fluid3D([7554,7264,6694,7085],0); -ELEMENTS[6506] = Fluid3D([7554,7264,7085,7985],0); -ELEMENTS[6507] = Fluid3D([7264,6694,7085,6375],0); -ELEMENTS[6508] = Fluid3D([7264,7985,7971,7578],0); -ELEMENTS[6509] = Fluid3D([6654,6430,5980,6080],0); -ELEMENTS[6510] = Fluid3D([6654,6430,6080,6817],0); -ELEMENTS[6511] = Fluid3D([6080,6654,6817,6161],0); -ELEMENTS[6512] = Fluid3D([6654,6430,6817,7157],0); -ELEMENTS[6513] = Fluid3D([6817,6654,7157,7635],0); -ELEMENTS[6514] = Fluid3D([6430,5980,6080,5739],0); -ELEMENTS[6515] = Fluid3D([6080,6430,5739,6159],0); -ELEMENTS[6516] = Fluid3D([6080,6430,6159,6722],0); -ELEMENTS[6517] = Fluid3D([6430,6159,6722,6585],0); -ELEMENTS[6518] = Fluid3D([6159,6722,6585,6614],0); -ELEMENTS[6519] = Fluid3D([6159,6722,6614,5990],0); -ELEMENTS[6520] = Fluid3D([6159,6722,5990,6333],0); -ELEMENTS[6521] = Fluid3D([6614,6159,5990,5865],0); -ELEMENTS[6522] = Fluid3D([6159,5990,5865,5547],0); -ELEMENTS[6523] = Fluid3D([6159,5990,5547,6080],0); -ELEMENTS[6524] = Fluid3D([5990,5865,5547,5574],0); -ELEMENTS[6525] = Fluid3D([5990,5865,5574,6239],0); -ELEMENTS[6526] = Fluid3D([5547,5990,5574,5661],0); -ELEMENTS[6527] = Fluid3D([5547,5990,5661,6080],0); -ELEMENTS[6528] = Fluid3D([5990,6159,6333,6080],0); -ELEMENTS[6529] = Fluid3D([5865,6159,5547,5683],0); -ELEMENTS[6530] = Fluid3D([6159,5547,5683,5739],0); -ELEMENTS[6531] = Fluid3D([5683,6159,5739,6585],0); -ELEMENTS[6532] = Fluid3D([5547,5683,5739,5094],0); -ELEMENTS[6533] = Fluid3D([5683,5739,5094,5472],0); -ELEMENTS[6534] = Fluid3D([5683,5739,5472,6032],0); -ELEMENTS[6535] = Fluid3D([5683,5739,6032,6585],0); -ELEMENTS[6536] = Fluid3D([5094,5683,5472,5189],0); -ELEMENTS[6537] = Fluid3D([5472,5683,6032,5829],0); -ELEMENTS[6538] = Fluid3D([5683,5472,5189,5829],0); -ELEMENTS[6539] = Fluid3D([5739,5472,6032,5894],0); -ELEMENTS[6540] = Fluid3D([5683,6032,5829,6585],0); -ELEMENTS[6541] = Fluid3D([5094,5683,5189,5236],0); -ELEMENTS[6542] = Fluid3D([5094,5683,5236,5547],0); -ELEMENTS[6543] = Fluid3D([5683,5236,5547,5865],0); -ELEMENTS[6544] = Fluid3D([5236,5547,5865,5574],0); -ELEMENTS[6545] = Fluid3D([5189,5683,5829,5631],0); -ELEMENTS[6546] = Fluid3D([5236,5094,5547,4898],0); -ELEMENTS[6547] = Fluid3D([5547,5236,4898,5574],0); -ELEMENTS[6548] = Fluid3D([6032,5739,5894,6430],0); -ELEMENTS[6549] = Fluid3D([5739,5472,5894,5302],0); -ELEMENTS[6550] = Fluid3D([5990,5574,5661,6239],0); -ELEMENTS[6551] = Fluid3D([6032,5739,6430,6585],0); -ELEMENTS[6552] = Fluid3D([5829,5189,5631,5383],0); -ELEMENTS[6553] = Fluid3D([5829,5189,5383,5264],0); -ELEMENTS[6554] = Fluid3D([5829,5189,5264,5472],0); -ELEMENTS[6555] = Fluid3D([5739,5472,5302,5094],0); -ELEMENTS[6556] = Fluid3D([5683,5189,5236,5631],0); -ELEMENTS[6557] = Fluid3D([5683,5829,5631,6296],0); -ELEMENTS[6558] = Fluid3D([5865,6159,5683,6296],0); -ELEMENTS[6559] = Fluid3D([5683,5829,6296,6585],0); -ELEMENTS[6560] = Fluid3D([5236,5683,5631,5865],0); -ELEMENTS[6561] = Fluid3D([5683,5631,5865,6296],0); -ELEMENTS[6562] = Fluid3D([5631,5236,5865,5441],0); -ELEMENTS[6563] = Fluid3D([5865,5631,5441,6067],0); -ELEMENTS[6564] = Fluid3D([5865,5631,6067,6296],0); -ELEMENTS[6565] = Fluid3D([5189,5631,5383,5035],0); -ELEMENTS[6566] = Fluid3D([5574,5547,5661,4898],0); -ELEMENTS[6567] = Fluid3D([5189,5631,5035,5236],0); -ELEMENTS[6568] = Fluid3D([5631,5441,6067,5564],0); -ELEMENTS[6569] = Fluid3D([6067,5631,5564,6063],0); -ELEMENTS[6570] = Fluid3D([6067,5631,6063,6296],0); -ELEMENTS[6571] = Fluid3D([5631,5441,5564,5035],0); -ELEMENTS[6572] = Fluid3D([5236,5094,4898,4679],0); -ELEMENTS[6573] = Fluid3D([4898,5236,4679,4745],0); -ELEMENTS[6574] = Fluid3D([4898,5236,4745,5574],0); -ELEMENTS[6575] = Fluid3D([5236,4679,4745,5035],0); -ELEMENTS[6576] = Fluid3D([5236,5094,4679,5189],0); -ELEMENTS[6577] = Fluid3D([5189,5383,5264,4797],0); -ELEMENTS[6578] = Fluid3D([5631,5829,5383,6063],0); -ELEMENTS[6579] = Fluid3D([5829,5631,6296,6063],0); -ELEMENTS[6580] = Fluid3D([5894,5739,5302,5980],0); -ELEMENTS[6581] = Fluid3D([5894,5739,5980,6430],0); -ELEMENTS[6582] = Fluid3D([5441,5865,6067,5970],0); -ELEMENTS[6583] = Fluid3D([5865,6067,5970,6614],0); -ELEMENTS[6584] = Fluid3D([5441,5865,5970,5574],0); -ELEMENTS[6585] = Fluid3D([5383,5829,5264,5783],0); -ELEMENTS[6586] = Fluid3D([5264,5189,4797,4795],0); -ELEMENTS[6587] = Fluid3D([6430,6159,6585,5739],0); -ELEMENTS[6588] = Fluid3D([5236,5865,5441,5574],0); -ELEMENTS[6589] = Fluid3D([4797,5264,4795,4718],0); -ELEMENTS[6590] = Fluid3D([5264,4795,4718,5058],0); -ELEMENTS[6591] = Fluid3D([5264,4795,5058,5472],0); -ELEMENTS[6592] = Fluid3D([5829,5264,5783,5929],0); -ELEMENTS[6593] = Fluid3D([5829,5264,5929,5472],0); -ELEMENTS[6594] = Fluid3D([5783,5829,5929,6387],0); -ELEMENTS[6595] = Fluid3D([5783,5829,6387,6063],0); -ELEMENTS[6596] = Fluid3D([5264,5783,5929,5477],0); -ELEMENTS[6597] = Fluid3D([5929,5264,5477,5058],0); -ELEMENTS[6598] = Fluid3D([5631,5236,5441,5035],0); -ELEMENTS[6599] = Fluid3D([5564,6067,6063,6178],0); -ELEMENTS[6600] = Fluid3D([6067,6063,6178,6908],0); -ELEMENTS[6601] = Fluid3D([5564,6067,6178,5809],0); -ELEMENTS[6602] = Fluid3D([5564,6067,5809,5441],0); -ELEMENTS[6603] = Fluid3D([6178,6067,6908,6590],0); -ELEMENTS[6604] = Fluid3D([5829,5929,6387,6032],0); -ELEMENTS[6605] = Fluid3D([6067,6063,6908,6296],0); -ELEMENTS[6606] = Fluid3D([5383,5189,5035,4797],0); -ELEMENTS[6607] = Fluid3D([5865,5970,5574,6239],0); -ELEMENTS[6608] = Fluid3D([5970,5574,6239,5756],0); -ELEMENTS[6609] = Fluid3D([6239,5970,5756,6373],0); -ELEMENTS[6610] = Fluid3D([6239,5970,6373,6875],0); -ELEMENTS[6611] = Fluid3D([6239,5970,6875,6614],0); -ELEMENTS[6612] = Fluid3D([6875,6239,6614,6755],0); -ELEMENTS[6613] = Fluid3D([5970,6373,6875,6590],0); -ELEMENTS[6614] = Fluid3D([6373,6239,6875,6985],0); -ELEMENTS[6615] = Fluid3D([5970,5756,6373,5898],0); -ELEMENTS[6616] = Fluid3D([5756,6239,6373,6337],0); -ELEMENTS[6617] = Fluid3D([5970,6875,6614,6067],0); -ELEMENTS[6618] = Fluid3D([6373,5970,5898,6590],0); -ELEMENTS[6619] = Fluid3D([6239,6875,6985,6755],0); -ELEMENTS[6620] = Fluid3D([5970,5756,5898,5339],0); -ELEMENTS[6621] = Fluid3D([5970,5756,5339,5574],0); -ELEMENTS[6622] = Fluid3D([6373,6239,6985,6337],0); -ELEMENTS[6623] = Fluid3D([5756,6239,6337,5878],0); -ELEMENTS[6624] = Fluid3D([5756,6239,5878,5574],0); -ELEMENTS[6625] = Fluid3D([5339,5970,5574,5441],0); -ELEMENTS[6626] = Fluid3D([5339,5970,5441,5809],0); -ELEMENTS[6627] = Fluid3D([5574,5339,5441,4745],0); -ELEMENTS[6628] = Fluid3D([5898,5970,5339,5809],0); -ELEMENTS[6629] = Fluid3D([6239,6985,6337,6755],0); -ELEMENTS[6630] = Fluid3D([6239,6337,5878,6250],0); -ELEMENTS[6631] = Fluid3D([6337,5878,6250,5885],0); -ELEMENTS[6632] = Fluid3D([5878,6250,5885,5542],0); -ELEMENTS[6633] = Fluid3D([6239,5970,6614,5865],0); -ELEMENTS[6634] = Fluid3D([6875,6373,6985,7069],0); -ELEMENTS[6635] = Fluid3D([6985,6373,6337,6923],0); -ELEMENTS[6636] = Fluid3D([6373,6337,6923,6225],0); -ELEMENTS[6637] = Fluid3D([6373,6337,6225,5756],0); -ELEMENTS[6638] = Fluid3D([6985,6373,6923,7069],0); -ELEMENTS[6639] = Fluid3D([5756,5339,5574,5150],0); -ELEMENTS[6640] = Fluid3D([5339,5574,5150,4745],0); -ELEMENTS[6641] = Fluid3D([5756,5339,5150,5350],0); -ELEMENTS[6642] = Fluid3D([5339,5150,5350,4720],0); -ELEMENTS[6643] = Fluid3D([5339,5150,4720,4745],0); -ELEMENTS[6644] = Fluid3D([5756,5339,5350,5898],0); -ELEMENTS[6645] = Fluid3D([5350,5339,4720,5087],0); -ELEMENTS[6646] = Fluid3D([5350,5339,5087,5898],0); -ELEMENTS[6647] = Fluid3D([5339,4720,5087,4893],0); -ELEMENTS[6648] = Fluid3D([5339,4720,4893,4745],0); -ELEMENTS[6649] = Fluid3D([5087,5339,4893,5809],0); -ELEMENTS[6650] = Fluid3D([5756,6373,5898,6225],0); -ELEMENTS[6651] = Fluid3D([6337,5878,5885,5756],0); -ELEMENTS[6652] = Fluid3D([6032,5472,5829,5929],0); -ELEMENTS[6653] = Fluid3D([5264,5189,4795,5472],0); -ELEMENTS[6654] = Fluid3D([5472,5894,5302,5512],0); -ELEMENTS[6655] = Fluid3D([5472,5894,5512,5929],0); -ELEMENTS[6656] = Fluid3D([5894,5302,5512,5549],0); -ELEMENTS[6657] = Fluid3D([5302,5512,5549,4935],0); -ELEMENTS[6658] = Fluid3D([5302,5512,4935,4883],0); -ELEMENTS[6659] = Fluid3D([5302,5512,4883,5472],0); -ELEMENTS[6660] = Fluid3D([5990,6614,5865,6239],0); -ELEMENTS[6661] = Fluid3D([6923,6373,6225,6604],0); -ELEMENTS[6662] = Fluid3D([6923,6373,6604,7069],0); -ELEMENTS[6663] = Fluid3D([6373,6225,6604,5898],0); -ELEMENTS[6664] = Fluid3D([5631,5383,5035,5564],0); -ELEMENTS[6665] = Fluid3D([6067,5441,5970,5809],0); -ELEMENTS[6666] = Fluid3D([5472,6032,5894,5929],0); -ELEMENTS[6667] = Fluid3D([4679,4898,4745,4337],0); -ELEMENTS[6668] = Fluid3D([4898,4745,4337,4734],0); -ELEMENTS[6669] = Fluid3D([4898,4745,4734,5574],0); -ELEMENTS[6670] = Fluid3D([4337,4898,4734,4500],0); -ELEMENTS[6671] = Fluid3D([4679,4898,4337,4531],0); -ELEMENTS[6672] = Fluid3D([4898,4734,4500,5021],0); -ELEMENTS[6673] = Fluid3D([4898,4734,5021,5574],0); -ELEMENTS[6674] = Fluid3D([4679,4898,4531,5094],0); -ELEMENTS[6675] = Fluid3D([4337,4898,4500,4531],0); -ELEMENTS[6676] = Fluid3D([4745,4337,4734,4281],0); -ELEMENTS[6677] = Fluid3D([4734,4745,4281,4720],0); -ELEMENTS[6678] = Fluid3D([5264,5383,5783,5178],0); -ELEMENTS[6679] = Fluid3D([5383,5829,5783,6063],0); -ELEMENTS[6680] = Fluid3D([5631,5564,6063,5383],0); -ELEMENTS[6681] = Fluid3D([5472,5094,5189,4795],0); -ELEMENTS[6682] = Fluid3D([6985,6875,7069,7831],0); -ELEMENTS[6683] = Fluid3D([5189,4797,4795,4679],0); -ELEMENTS[6684] = Fluid3D([5383,5264,4797,5178],0); -ELEMENTS[6685] = Fluid3D([4797,5264,4718,5178],0); -ELEMENTS[6686] = Fluid3D([4795,4718,5058,4466],0); -ELEMENTS[6687] = Fluid3D([4795,4718,4466,4295],0); -ELEMENTS[6688] = Fluid3D([4795,4718,4295,4797],0); -ELEMENTS[6689] = Fluid3D([5302,5739,5094,5283],0); -ELEMENTS[6690] = Fluid3D([5739,5094,5283,5547],0); -ELEMENTS[6691] = Fluid3D([5302,5739,5283,5980],0); -ELEMENTS[6692] = Fluid3D([5980,6654,6080,5921],0); -ELEMENTS[6693] = Fluid3D([5980,6654,5921,6375],0); -ELEMENTS[6694] = Fluid3D([6654,6080,5921,6161],0); -ELEMENTS[6695] = Fluid3D([5980,6080,5739,5283],0); -ELEMENTS[6696] = Fluid3D([5739,6080,6159,5547],0); -ELEMENTS[6697] = Fluid3D([7554,8022,7985,8444],0); -ELEMENTS[6698] = Fluid3D([7985,7554,8444,7680],0); -ELEMENTS[6699] = Fluid3D([8444,7985,7680,8382],0); -ELEMENTS[6700] = Fluid3D([7985,7554,7680,7085],0); -ELEMENTS[6701] = Fluid3D([7680,7985,7085,7486],0); -ELEMENTS[6702] = Fluid3D([7085,7680,7486,7059],0); -ELEMENTS[6703] = Fluid3D([7085,7680,7059,7027],0); -ELEMENTS[6704] = Fluid3D([7085,7680,7027,7554],0); -ELEMENTS[6705] = Fluid3D([7486,7085,7059,6637],0); -ELEMENTS[6706] = Fluid3D([7486,7085,6637,7264],0); -ELEMENTS[6707] = Fluid3D([7680,7985,7486,8382],0); -ELEMENTS[6708] = Fluid3D([7680,7486,7059,8382],0); -ELEMENTS[6709] = Fluid3D([7985,7085,7486,7264],0); -ELEMENTS[6710] = Fluid3D([7059,7085,7027,6084],0); -ELEMENTS[6711] = Fluid3D([7085,7059,6637,6084],0); -ELEMENTS[6712] = Fluid3D([7680,7059,7027,7605],0); -ELEMENTS[6713] = Fluid3D([7059,7486,6637,7495],0); -ELEMENTS[6714] = Fluid3D([7680,7059,7605,8382],0); -ELEMENTS[6715] = Fluid3D([7027,7680,7605,7828],0); -ELEMENTS[6716] = Fluid3D([7027,7680,7828,7554],0); -ELEMENTS[6717] = Fluid3D([7680,7605,7828,8424],0); -ELEMENTS[6718] = Fluid3D([7680,7605,8424,8382],0); -ELEMENTS[6719] = Fluid3D([7828,7680,8424,8444],0); -ELEMENTS[6720] = Fluid3D([7059,7027,7605,6771],0); -ELEMENTS[6721] = Fluid3D([7605,7027,7828,7279],0); -ELEMENTS[6722] = Fluid3D([8022,7985,8444,8851],0); -ELEMENTS[6723] = Fluid3D([7985,8444,8851,8290],0); -ELEMENTS[6724] = Fluid3D([7985,8444,8290,8382],0); -ELEMENTS[6725] = Fluid3D([8851,7985,8290,7971],0); -ELEMENTS[6726] = Fluid3D([7985,8290,7971,7578],0); -ELEMENTS[6727] = Fluid3D([7059,7027,6771,6084],0); -ELEMENTS[6728] = Fluid3D([7828,7605,7279,8134],0); -ELEMENTS[6729] = Fluid3D([7279,7828,8134,7911],0); -ELEMENTS[6730] = Fluid3D([7279,7828,7911,7154],0); -ELEMENTS[6731] = Fluid3D([7279,7828,7154,7027],0); -ELEMENTS[6732] = Fluid3D([7605,7059,6771,7105],0); -ELEMENTS[6733] = Fluid3D([7027,7605,6771,7279],0); -ELEMENTS[6734] = Fluid3D([7605,7828,8424,8134],0); -ELEMENTS[6735] = Fluid3D([7605,7279,8134,7509],0); -ELEMENTS[6736] = Fluid3D([8134,7279,7911,7706],0); -ELEMENTS[6737] = Fluid3D([8134,7279,7706,7509],0); -ELEMENTS[6738] = Fluid3D([7680,8424,8444,8382],0); -ELEMENTS[6739] = Fluid3D([7828,8134,7911,8668],0); -ELEMENTS[6740] = Fluid3D([7828,8134,8668,8424],0); -ELEMENTS[6741] = Fluid3D([7911,7828,8668,8021],0); -ELEMENTS[6742] = Fluid3D([8134,7911,8668,8643],0); -ELEMENTS[6743] = Fluid3D([8668,8134,8643,9083],0); -ELEMENTS[6744] = Fluid3D([8668,8134,9083,8424],0); -ELEMENTS[6745] = Fluid3D([8134,7911,8643,7706],0); -ELEMENTS[6746] = Fluid3D([7605,7279,7509,6771],0); -ELEMENTS[6747] = Fluid3D([7911,8668,8643,8694],0); -ELEMENTS[6748] = Fluid3D([7911,8668,8694,8021],0); -ELEMENTS[6749] = Fluid3D([8668,8643,8694,9321],0); -ELEMENTS[6750] = Fluid3D([8643,7911,8694,8164],0); -ELEMENTS[6751] = Fluid3D([8643,7911,8164,7706],0); -ELEMENTS[6752] = Fluid3D([8694,8643,8164,9358],0); -ELEMENTS[6753] = Fluid3D([8694,8643,9358,9321],0); -ELEMENTS[6754] = Fluid3D([8643,8164,9358,8566],0); -ELEMENTS[6755] = Fluid3D([8643,8164,8566,7706],0); -ELEMENTS[6756] = Fluid3D([8164,9358,8566,8589],0); -ELEMENTS[6757] = Fluid3D([8164,9358,8589,8850],0); -ELEMENTS[6758] = Fluid3D([8164,9358,8850,8694],0); -ELEMENTS[6759] = Fluid3D([9358,8566,8589,9529],0); -ELEMENTS[6760] = Fluid3D([9358,8566,9529,9464],0); -ELEMENTS[6761] = Fluid3D([9358,8566,9464,8643],0); -ELEMENTS[6762] = Fluid3D([8566,8589,9529,8593],0); -ELEMENTS[6763] = Fluid3D([8566,8589,8593,7820],0); -ELEMENTS[6764] = Fluid3D([8566,8589,7820,8164],0); -ELEMENTS[6765] = Fluid3D([8589,9529,8593,9142],0); -ELEMENTS[6766] = Fluid3D([8589,9529,9142,9481],0); -ELEMENTS[6767] = Fluid3D([8589,9529,9481,9358],0); -ELEMENTS[6768] = Fluid3D([9529,8593,9142,9572],0); -ELEMENTS[6769] = Fluid3D([9529,8593,9572,9189],0); -ELEMENTS[6770] = Fluid3D([9529,8593,9189,8566],0); -ELEMENTS[6771] = Fluid3D([8593,9142,9572,8789],0); -ELEMENTS[6772] = Fluid3D([8593,9142,8789,8188],0); -ELEMENTS[6773] = Fluid3D([8593,9142,8188,8589],0); -ELEMENTS[6774] = Fluid3D([9142,9572,8789,9689],0); -ELEMENTS[6775] = Fluid3D([9142,9572,9689,10116],0); -ELEMENTS[6776] = Fluid3D([9142,9572,10116,9529],0); -ELEMENTS[6777] = Fluid3D([9572,8789,9689,9584],0); -ELEMENTS[6778] = Fluid3D([9572,8789,9584,8859],0); -ELEMENTS[6779] = Fluid3D([9572,8789,8859,8593],0); -ELEMENTS[6780] = Fluid3D([8789,9689,9584,9169],0); -ELEMENTS[6781] = Fluid3D([8789,9689,9169,8927],0); -ELEMENTS[6782] = Fluid3D([8789,9689,8927,9142],0); -ELEMENTS[6783] = Fluid3D([9689,9584,9169,10143],0); -ELEMENTS[6784] = Fluid3D([9689,9584,10143,10429],0); -ELEMENTS[6785] = Fluid3D([9689,9584,10429,9572],0); -ELEMENTS[6786] = Fluid3D([9584,9169,10143,9535],0); -ELEMENTS[6787] = Fluid3D([9584,9169,9535,8672],0); -ELEMENTS[6788] = Fluid3D([9584,9169,8672,8789],0); -ELEMENTS[6789] = Fluid3D([9169,10143,9535,9717],0); -ELEMENTS[6790] = Fluid3D([9169,10143,9717,9822],0); -ELEMENTS[6791] = Fluid3D([9169,10143,9822,9689],0); -ELEMENTS[6792] = Fluid3D([10143,9535,9717,10457],0); -ELEMENTS[6793] = Fluid3D([10143,9535,10457,10372],0); -ELEMENTS[6794] = Fluid3D([10143,9535,10372,9584],0); -ELEMENTS[6795] = Fluid3D([9535,9717,10457,9655],0); -ELEMENTS[6796] = Fluid3D([9535,9717,9655,8844],0); -ELEMENTS[6797] = Fluid3D([9535,9717,8844,9169],0); -ELEMENTS[6798] = Fluid3D([9717,10457,9655,10365],0); -ELEMENTS[6799] = Fluid3D([9717,10457,10365,10714],0); -ELEMENTS[6800] = Fluid3D([9717,10457,10714,10143],0); -ELEMENTS[6801] = Fluid3D([10457,9655,10365,10596],0); -ELEMENTS[6802] = Fluid3D([10457,9655,10596,10109],0); -ELEMENTS[6803] = Fluid3D([10457,9655,10109,9535],0); -ELEMENTS[6804] = Fluid3D([9655,10365,10596,9953],0); -ELEMENTS[6805] = Fluid3D([9655,10365,9953,9387],0); -ELEMENTS[6806] = Fluid3D([9655,10365,9387,9717],0); -ELEMENTS[6807] = Fluid3D([10365,10596,9953,10974],0); -ELEMENTS[6808] = Fluid3D([10596,9953,10974,10680],0); -ELEMENTS[6809] = Fluid3D([10365,10596,10974,11336],0); -ELEMENTS[6810] = Fluid3D([10596,9953,10680,9857],0); -ELEMENTS[6811] = Fluid3D([10596,9953,9857,9655],0); -ELEMENTS[6812] = Fluid3D([10365,10596,11336,10457],0); -ELEMENTS[6813] = Fluid3D([8134,8643,9083,8552],0); -ELEMENTS[6814] = Fluid3D([8134,8643,8552,7706],0); -ELEMENTS[6815] = Fluid3D([8643,9083,8552,9464],0); -ELEMENTS[6816] = Fluid3D([7911,8694,8164,7860],0); -ELEMENTS[6817] = Fluid3D([7911,8694,7860,8021],0); -ELEMENTS[6818] = Fluid3D([8164,7911,7860,7297],0); -ELEMENTS[6819] = Fluid3D([7911,7860,7297,7154],0); -ELEMENTS[6820] = Fluid3D([8694,8164,7860,8850],0); -ELEMENTS[6821] = Fluid3D([8164,7911,7297,7706],0); -ELEMENTS[6822] = Fluid3D([7860,8164,7297,7655],0); -ELEMENTS[6823] = Fluid3D([8164,7297,7655,7820],0); -ELEMENTS[6824] = Fluid3D([7297,7860,7655,6944],0); -ELEMENTS[6825] = Fluid3D([7860,8164,7655,8850],0); -ELEMENTS[6826] = Fluid3D([7860,7655,6944,7753],0); -ELEMENTS[6827] = Fluid3D([7860,7655,7753,8850],0); -ELEMENTS[6828] = Fluid3D([7655,6944,7753,7113],0); -ELEMENTS[6829] = Fluid3D([7655,6944,7113,6809],0); -ELEMENTS[6830] = Fluid3D([6944,7753,7113,6987],0); -ELEMENTS[6831] = Fluid3D([7655,6944,6809,7297],0); -ELEMENTS[6832] = Fluid3D([6944,7753,6987,7258],0); -ELEMENTS[6833] = Fluid3D([7297,7860,6944,7154],0); -ELEMENTS[6834] = Fluid3D([9953,10365,10974,10260],0); -ELEMENTS[6835] = Fluid3D([9953,10365,10260,9387],0); -ELEMENTS[6836] = Fluid3D([10365,10974,10260,11108],0); -ELEMENTS[6837] = Fluid3D([10260,10365,11108,10184],0); -ELEMENTS[6838] = Fluid3D([10260,10365,10184,9387],0); -ELEMENTS[6839] = Fluid3D([10365,10974,11108,11336],0); -ELEMENTS[6840] = Fluid3D([11108,10260,10184,10703],0); -ELEMENTS[6841] = Fluid3D([11108,10260,10703,11115],0); -ELEMENTS[6842] = Fluid3D([11108,10260,11115,10974],0); -ELEMENTS[6843] = Fluid3D([10260,10184,10703,9661],0); -ELEMENTS[6844] = Fluid3D([10260,10184,9661,9387],0); -ELEMENTS[6845] = Fluid3D([10184,10703,9661,9908],0); -ELEMENTS[6846] = Fluid3D([10184,10703,9908,11016],0); -ELEMENTS[6847] = Fluid3D([10703,9661,9908,10120],0); -ELEMENTS[6848] = Fluid3D([10184,10703,11016,11108],0); -ELEMENTS[6849] = Fluid3D([10703,9661,10120,10215],0); -ELEMENTS[6850] = Fluid3D([10703,9661,10215,10260],0); -ELEMENTS[6851] = Fluid3D([10120,10703,10215,11053],0); -ELEMENTS[6852] = Fluid3D([10703,10215,11053,11115],0); -ELEMENTS[6853] = Fluid3D([10120,10703,11053,11124],0); -ELEMENTS[6854] = Fluid3D([10703,11053,11124,11709],0); -ELEMENTS[6855] = Fluid3D([10703,11053,11709,11115],0); -ELEMENTS[6856] = Fluid3D([10120,10703,11124,9908],0); -ELEMENTS[6857] = Fluid3D([10260,10703,11115,10215],0); -ELEMENTS[6858] = Fluid3D([10215,10120,11053,10230],0); -ELEMENTS[6859] = Fluid3D([11053,10215,10230,10896],0); -ELEMENTS[6860] = Fluid3D([10120,11053,10230,10768],0); -ELEMENTS[6861] = Fluid3D([10120,11053,10768,11124],0); -ELEMENTS[6862] = Fluid3D([10215,10120,10230,9366],0); -ELEMENTS[6863] = Fluid3D([10215,10120,9366,9661],0); -ELEMENTS[6864] = Fluid3D([10120,10230,9366,9615],0); -ELEMENTS[6865] = Fluid3D([10120,10230,9615,10768],0); -ELEMENTS[6866] = Fluid3D([10230,9366,9615,9356],0); -ELEMENTS[6867] = Fluid3D([9366,9615,9356,8676],0); -ELEMENTS[6868] = Fluid3D([9366,9615,8676,9089],0); -ELEMENTS[6869] = Fluid3D([9366,9615,9089,10120],0); -ELEMENTS[6870] = Fluid3D([10230,9366,9356,9709],0); -ELEMENTS[6871] = Fluid3D([10230,9366,9709,10215],0); -ELEMENTS[6872] = Fluid3D([9366,9356,9709,8748],0); -ELEMENTS[6873] = Fluid3D([9356,9709,8748,9130],0); -ELEMENTS[6874] = Fluid3D([9356,9709,9130,10089],0); -ELEMENTS[6875] = Fluid3D([9356,9709,10089,10230],0); -ELEMENTS[6876] = Fluid3D([9366,9356,8748,8676],0); -ELEMENTS[6877] = Fluid3D([11053,10215,10896,11115],0); -ELEMENTS[6878] = Fluid3D([10974,9953,10260,10377],0); -ELEMENTS[6879] = Fluid3D([9953,10260,10377,9491],0); -ELEMENTS[6880] = Fluid3D([10260,10974,10377,11115],0); -ELEMENTS[6881] = Fluid3D([10974,9953,10377,10680],0); -ELEMENTS[6882] = Fluid3D([9953,10260,9491,9387],0); -ELEMENTS[6883] = Fluid3D([10377,9953,9491,9682],0); -ELEMENTS[6884] = Fluid3D([9953,9491,9682,9000],0); -ELEMENTS[6885] = Fluid3D([9491,10377,9682,9788],0); -ELEMENTS[6886] = Fluid3D([9491,10377,9788,10215],0); -ELEMENTS[6887] = Fluid3D([10377,9953,9682,10680],0); -ELEMENTS[6888] = Fluid3D([9953,9491,9000,9387],0); -ELEMENTS[6889] = Fluid3D([10230,11053,10896,11229],0); -ELEMENTS[6890] = Fluid3D([10896,10230,11229,10089],0); -ELEMENTS[6891] = Fluid3D([11053,10896,11229,11832],0); -ELEMENTS[6892] = Fluid3D([10896,11229,11832,11604],0); -ELEMENTS[6893] = Fluid3D([10896,11229,11604,10089],0); -ELEMENTS[6894] = Fluid3D([10230,11053,11229,10768],0); -ELEMENTS[6895] = Fluid3D([11229,11053,11832,11908],0); -ELEMENTS[6896] = Fluid3D([9491,9682,9000,8823],0); -ELEMENTS[6897] = Fluid3D([9682,9000,8823,8843],0); -ELEMENTS[6898] = Fluid3D([9000,9491,8823,8556],0); -ELEMENTS[6899] = Fluid3D([9000,9491,8556,9387],0); -ELEMENTS[6900] = Fluid3D([9491,9682,8823,9788],0); -ELEMENTS[6901] = Fluid3D([9000,8823,8843,7996],0); -ELEMENTS[6902] = Fluid3D([9000,8823,7996,8556],0); -ELEMENTS[6903] = Fluid3D([8823,8843,7996,8196],0); -ELEMENTS[6904] = Fluid3D([8823,8843,8196,8998],0); -ELEMENTS[6905] = Fluid3D([8823,8843,8998,9682],0); -ELEMENTS[6906] = Fluid3D([8843,7996,8196,8308],0); -ELEMENTS[6907] = Fluid3D([8843,7996,8308,8441],0); -ELEMENTS[6908] = Fluid3D([8843,7996,8441,9000],0); -ELEMENTS[6909] = Fluid3D([8196,8843,8308,8545],0); -ELEMENTS[6910] = Fluid3D([8308,8196,8545,7542],0); -ELEMENTS[6911] = Fluid3D([8308,8196,7542,7498],0); -ELEMENTS[6912] = Fluid3D([8196,8843,8545,8998],0); -ELEMENTS[6913] = Fluid3D([8308,8196,7498,7996],0); -ELEMENTS[6914] = Fluid3D([11053,10896,11832,11115],0); -ELEMENTS[6915] = Fluid3D([9682,9000,8843,9857],0); -ELEMENTS[6916] = Fluid3D([7996,8823,8196,7951],0); -ELEMENTS[6917] = Fluid3D([7996,8823,7951,8556],0); -ELEMENTS[6918] = Fluid3D([8823,8196,7951,8536],0); -ELEMENTS[6919] = Fluid3D([7951,8823,8536,8591],0); -ELEMENTS[6920] = Fluid3D([8823,8196,8536,8998],0); -ELEMENTS[6921] = Fluid3D([7951,8823,8591,8556],0); -ELEMENTS[6922] = Fluid3D([8823,8536,8591,9788],0); -ELEMENTS[6923] = Fluid3D([8196,7996,7951,7498],0); -ELEMENTS[6924] = Fluid3D([8196,7951,8536,7664],0); -ELEMENTS[6925] = Fluid3D([7951,8536,7664,7868],0); -ELEMENTS[6926] = Fluid3D([8536,7664,7868,8176],0); -ELEMENTS[6927] = Fluid3D([8536,7664,8176,8462],0); -ELEMENTS[6928] = Fluid3D([8536,7664,8462,8196],0); -ELEMENTS[6929] = Fluid3D([8196,7951,7664,7498],0); -ELEMENTS[6930] = Fluid3D([7951,8536,7868,8591],0); -ELEMENTS[6931] = Fluid3D([7664,7951,7868,7156],0); -ELEMENTS[6932] = Fluid3D([7951,7868,7156,7810],0); -ELEMENTS[6933] = Fluid3D([7868,7156,7810,7171],0); -ELEMENTS[6934] = Fluid3D([7868,7156,7171,7133],0); -ELEMENTS[6935] = Fluid3D([7868,7156,7133,7664],0); -ELEMENTS[6936] = Fluid3D([7664,7951,7156,7498],0); -ELEMENTS[6937] = Fluid3D([7951,7868,7810,8591],0); -ELEMENTS[6938] = Fluid3D([7156,7810,7171,6792],0); -ELEMENTS[6939] = Fluid3D([7156,7810,6792,7218],0); -ELEMENTS[6940] = Fluid3D([7810,6792,7218,7308],0); -ELEMENTS[6941] = Fluid3D([7810,7171,6792,7290],0); -ELEMENTS[6942] = Fluid3D([7810,7171,7290,8073],0); -ELEMENTS[6943] = Fluid3D([7810,6792,7308,7290],0); -ELEMENTS[6944] = Fluid3D([7810,7171,8073,7868],0); -ELEMENTS[6945] = Fluid3D([6792,7156,7218,6446],0); -ELEMENTS[6946] = Fluid3D([6792,7156,6446,6370],0); -ELEMENTS[6947] = Fluid3D([7156,7218,6446,7498],0); -ELEMENTS[6948] = Fluid3D([7218,6792,6446,6496],0); -ELEMENTS[6949] = Fluid3D([7218,6792,6496,7308],0); -ELEMENTS[6950] = Fluid3D([6792,6446,6496,6011],0); -ELEMENTS[6951] = Fluid3D([6792,6446,6011,6370],0); -ELEMENTS[6952] = Fluid3D([6446,6496,6011,5923],0); -ELEMENTS[6953] = Fluid3D([6446,6496,5923,6458],0); -ELEMENTS[6954] = Fluid3D([6446,6496,6458,7218],0); -ELEMENTS[6955] = Fluid3D([6496,6011,5923,5851],0); -ELEMENTS[6956] = Fluid3D([6496,6011,5851,6329],0); -ELEMENTS[6957] = Fluid3D([6011,5923,5851,5402],0); -ELEMENTS[6958] = Fluid3D([6496,6011,6329,6792],0); -ELEMENTS[6959] = Fluid3D([6011,5923,5402,5673],0); -ELEMENTS[6960] = Fluid3D([5923,5402,5673,5351],0); -ELEMENTS[6961] = Fluid3D([5923,5402,5351,5396],0); -ELEMENTS[6962] = Fluid3D([5923,5402,5396,5851],0); -ELEMENTS[6963] = Fluid3D([6011,5923,5673,6446],0); -ELEMENTS[6964] = Fluid3D([6792,7156,6370,7171],0); -ELEMENTS[6965] = Fluid3D([7156,7810,7218,7951],0); -ELEMENTS[6966] = Fluid3D([7828,7911,7154,8021],0); -ELEMENTS[6967] = Fluid3D([6694,7554,7085,7027],0); -ELEMENTS[6968] = Fluid3D([6080,5980,5921,5283],0); -ELEMENTS[6969] = Fluid3D([6333,6722,6817,6080],0); -ELEMENTS[6970] = Fluid3D([8666,8021,8413,8915],0); -ELEMENTS[6971] = Fluid3D([8666,8021,8915,8968],0); -ELEMENTS[6972] = Fluid3D([8021,8413,8915,7860],0); -ELEMENTS[6973] = Fluid3D([8413,8666,8915,9328],0); -ELEMENTS[6974] = Fluid3D([8413,8666,9328,8622],0); -ELEMENTS[6975] = Fluid3D([8915,8413,9328,9095],0); -ELEMENTS[6976] = Fluid3D([8413,9328,9095,8994],0); -ELEMENTS[6977] = Fluid3D([8413,9328,8994,8622],0); -ELEMENTS[6978] = Fluid3D([9328,9095,8994,10014],0); -ELEMENTS[6979] = Fluid3D([9328,9095,10014,9741],0); -ELEMENTS[6980] = Fluid3D([8994,9328,10014,9999],0); -ELEMENTS[6981] = Fluid3D([9328,10014,9999,10753],0); -ELEMENTS[6982] = Fluid3D([8915,8413,9095,7860],0); -ELEMENTS[6983] = Fluid3D([9095,8994,10014,9307],0); -ELEMENTS[6984] = Fluid3D([8994,10014,9307,9702],0); -ELEMENTS[6985] = Fluid3D([9095,8994,9307,8397],0); -ELEMENTS[6986] = Fluid3D([10014,9307,9702,10310],0); -ELEMENTS[6987] = Fluid3D([10014,9307,10310,10093],0); -ELEMENTS[6988] = Fluid3D([10014,9307,10093,9095],0); -ELEMENTS[6989] = Fluid3D([9095,8994,8397,8413],0); -ELEMENTS[6990] = Fluid3D([8994,10014,9702,9999],0); -ELEMENTS[6991] = Fluid3D([8994,9307,8397,8698],0); -ELEMENTS[6992] = Fluid3D([9307,8397,8698,8613],0); -ELEMENTS[6993] = Fluid3D([8397,8698,8613,7753],0); -ELEMENTS[6994] = Fluid3D([8613,8397,7753,8850],0); -ELEMENTS[6995] = Fluid3D([8994,9307,8698,9702],0); -ELEMENTS[6996] = Fluid3D([9307,8397,8613,8850],0); -ELEMENTS[6997] = Fluid3D([8397,8994,8698,8042],0); -ELEMENTS[6998] = Fluid3D([8397,8994,8042,8413],0); -ELEMENTS[6999] = Fluid3D([8698,8397,8042,7753],0); -ELEMENTS[7000] = Fluid3D([8397,8042,7753,7258],0); -ELEMENTS[7001] = Fluid3D([8994,8698,8042,8794],0); -ELEMENTS[7002] = Fluid3D([8042,8994,8794,8622],0); -ELEMENTS[7003] = Fluid3D([8994,8698,8794,9702],0); -ELEMENTS[7004] = Fluid3D([8698,9307,8613,9371],0); -ELEMENTS[7005] = Fluid3D([9307,8613,9371,9513],0); -ELEMENTS[7006] = Fluid3D([8698,9307,9371,9702],0); -ELEMENTS[7007] = Fluid3D([8613,8698,9371,8495],0); -ELEMENTS[7008] = Fluid3D([8698,9371,8495,9097],0); -ELEMENTS[7009] = Fluid3D([8698,9371,9097,9702],0); -ELEMENTS[7010] = Fluid3D([8613,8698,8495,7854],0); -ELEMENTS[7011] = Fluid3D([8613,8698,7854,7753],0); -ELEMENTS[7012] = Fluid3D([8698,8495,7854,8089],0); -ELEMENTS[7013] = Fluid3D([8495,7854,8089,7627],0); -ELEMENTS[7014] = Fluid3D([8698,8495,8089,9097],0); -ELEMENTS[7015] = Fluid3D([8495,7854,7627,7897],0); -ELEMENTS[7016] = Fluid3D([8495,7854,7897,8613],0); -ELEMENTS[7017] = Fluid3D([7854,7627,7897,7106],0); -ELEMENTS[7018] = Fluid3D([7854,7627,7106,7158],0); -ELEMENTS[7019] = Fluid3D([7854,7627,7158,8089],0); -ELEMENTS[7020] = Fluid3D([7627,7897,7106,7230],0); -ELEMENTS[7021] = Fluid3D([7106,7627,7230,6757],0); -ELEMENTS[7022] = Fluid3D([7106,7627,6757,7158],0); -ELEMENTS[7023] = Fluid3D([7627,7897,7230,8058],0); -ELEMENTS[7024] = Fluid3D([7897,7230,8058,7827],0); -ELEMENTS[7025] = Fluid3D([7897,7230,7827,7223],0); -ELEMENTS[7026] = Fluid3D([7897,7230,7223,7106],0); -ELEMENTS[7027] = Fluid3D([7627,7897,8058,8495],0); -ELEMENTS[7028] = Fluid3D([9307,8613,9513,8850],0); -ELEMENTS[7029] = Fluid3D([9371,9307,9513,10310],0); -ELEMENTS[7030] = Fluid3D([8698,8042,8794,8089],0); -ELEMENTS[7031] = Fluid3D([8666,8915,9328,9741],0); -ELEMENTS[7032] = Fluid3D([8915,9328,9741,9095],0); -ELEMENTS[7033] = Fluid3D([8613,9371,9513,9034],0); -ELEMENTS[7034] = Fluid3D([9513,8613,9034,8750],0); -ELEMENTS[7035] = Fluid3D([8613,9371,9034,8495],0); -ELEMENTS[7036] = Fluid3D([9034,9513,8750,9595],0); -ELEMENTS[7037] = Fluid3D([9034,9513,9595,10027],0); -ELEMENTS[7038] = Fluid3D([9034,9513,10027,9371],0); -ELEMENTS[7039] = Fluid3D([8750,9034,9595,8739],0); -ELEMENTS[7040] = Fluid3D([9034,9595,8739,9502],0); -ELEMENTS[7041] = Fluid3D([9034,9595,9502,10027],0); -ELEMENTS[7042] = Fluid3D([8750,9034,8739,7897],0); -ELEMENTS[7043] = Fluid3D([9513,8613,8750,8850],0); -ELEMENTS[7044] = Fluid3D([9595,8750,8739,9016],0); -ELEMENTS[7045] = Fluid3D([9595,8750,9016,9481],0); -ELEMENTS[7046] = Fluid3D([8750,8739,9016,8103],0); -ELEMENTS[7047] = Fluid3D([9016,8750,8103,8188],0); -ELEMENTS[7048] = Fluid3D([8750,8739,8103,7897],0); -ELEMENTS[7049] = Fluid3D([8739,9595,9016,9483],0); -ELEMENTS[7050] = Fluid3D([8739,9595,9483,9502],0); -ELEMENTS[7051] = Fluid3D([9595,9016,9483,10001],0); -ELEMENTS[7052] = Fluid3D([9016,9483,10001,8927],0); -ELEMENTS[7053] = Fluid3D([9016,9483,8927,8739],0); -ELEMENTS[7054] = Fluid3D([10001,9016,8927,9142],0); -ELEMENTS[7055] = Fluid3D([9016,8927,9142,8188],0); -ELEMENTS[7056] = Fluid3D([9595,9016,10001,9481],0); -ELEMENTS[7057] = Fluid3D([9483,9595,10001,10397],0); -ELEMENTS[7058] = Fluid3D([9483,9595,10397,9502],0); -ELEMENTS[7059] = Fluid3D([9595,10001,10397,10520],0); -ELEMENTS[7060] = Fluid3D([10001,9483,10397,10347],0); -ELEMENTS[7061] = Fluid3D([10001,10397,10520,11044],0); -ELEMENTS[7062] = Fluid3D([10001,9483,10347,9822],0); -ELEMENTS[7063] = Fluid3D([10001,10397,11044,10347],0); -ELEMENTS[7064] = Fluid3D([9595,10001,10520,9481],0); -ELEMENTS[7065] = Fluid3D([10397,9595,10520,10027],0); -ELEMENTS[7066] = Fluid3D([8739,9016,8103,8927],0); -ELEMENTS[7067] = Fluid3D([9016,8103,8927,8188],0); -ELEMENTS[7068] = Fluid3D([8613,9034,8750,7897],0); -ELEMENTS[7069] = Fluid3D([9513,8750,9595,9481],0); -ELEMENTS[7070] = Fluid3D([9513,9595,10027,10520],0); -ELEMENTS[7071] = Fluid3D([7113,6944,6987,6362],0); -ELEMENTS[7072] = Fluid3D([7113,6944,6362,6809],0); -ELEMENTS[7073] = Fluid3D([6944,6987,6362,6387],0); -ELEMENTS[7074] = Fluid3D([6987,7113,6362,7106],0); -ELEMENTS[7075] = Fluid3D([6987,7113,7106,7854],0); -ELEMENTS[7076] = Fluid3D([9307,9702,10310,9371],0); -ELEMENTS[7077] = Fluid3D([9483,10397,10347,10135],0); -ELEMENTS[7078] = Fluid3D([9483,10397,10135,9502],0); -ELEMENTS[7079] = Fluid3D([10397,10347,10135,11111],0); -ELEMENTS[7080] = Fluid3D([10397,10347,11111,11044],0); -ELEMENTS[7081] = Fluid3D([10135,10397,11111,10774],0); -ELEMENTS[7082] = Fluid3D([10135,10397,10774,9502],0); -ELEMENTS[7083] = Fluid3D([10397,11111,10774,11379],0); -ELEMENTS[7084] = Fluid3D([10397,11111,11379,11044],0); -ELEMENTS[7085] = Fluid3D([11111,10774,11379,11767],0); -ELEMENTS[7086] = Fluid3D([10774,10397,11379,10586],0); -ELEMENTS[7087] = Fluid3D([10397,11379,10586,10520],0); -ELEMENTS[7088] = Fluid3D([10774,11379,11767,11645],0); -ELEMENTS[7089] = Fluid3D([10774,11379,11645,10586],0); -ELEMENTS[7090] = Fluid3D([11379,11767,11645,12302],0); -ELEMENTS[7091] = Fluid3D([11645,11379,12302,12159],0); -ELEMENTS[7092] = Fluid3D([11379,11767,12302,12128],0); -ELEMENTS[7093] = Fluid3D([11767,12302,12128,12736],0); -ELEMENTS[7094] = Fluid3D([11767,12302,12736,12409],0); -ELEMENTS[7095] = Fluid3D([11767,12302,12409,11645],0); -ELEMENTS[7096] = Fluid3D([11379,11767,12128,11111],0); -ELEMENTS[7097] = Fluid3D([10774,10397,10586,9502],0); -ELEMENTS[7098] = Fluid3D([11767,10774,11645,11347],0); -ELEMENTS[7099] = Fluid3D([10774,11645,11347,10632],0); -ELEMENTS[7100] = Fluid3D([11645,11767,11347,12409],0); -ELEMENTS[7101] = Fluid3D([11767,10774,11347,11091],0); -ELEMENTS[7102] = Fluid3D([10774,11347,11091,10359],0); -ELEMENTS[7103] = Fluid3D([10774,11347,10359,10632],0); -ELEMENTS[7104] = Fluid3D([11767,10774,11091,11111],0); -ELEMENTS[7105] = Fluid3D([10774,11645,10632,10586],0); -ELEMENTS[7106] = Fluid3D([10347,9483,10135,9508],0); -ELEMENTS[7107] = Fluid3D([10347,9483,9508,9822],0); -ELEMENTS[7108] = Fluid3D([9508,10347,9822,10446],0); -ELEMENTS[7109] = Fluid3D([10347,9822,10446,10826],0); -ELEMENTS[7110] = Fluid3D([10347,9822,10826,10001],0); -ELEMENTS[7111] = Fluid3D([10446,10347,10826,11183],0); -ELEMENTS[7112] = Fluid3D([9822,10446,10826,10714],0); -ELEMENTS[7113] = Fluid3D([10446,10826,10714,11183],0); -ELEMENTS[7114] = Fluid3D([10826,9822,10714,10143],0); -ELEMENTS[7115] = Fluid3D([10714,10826,10143,11216],0); -ELEMENTS[7116] = Fluid3D([10714,10826,11216,11565],0); -ELEMENTS[7117] = Fluid3D([10714,10826,11565,11183],0); -ELEMENTS[7118] = Fluid3D([10826,11216,11565,11688],0); -ELEMENTS[7119] = Fluid3D([11565,10826,11688,11183],0); -ELEMENTS[7120] = Fluid3D([10826,11216,11688,10429],0); -ELEMENTS[7121] = Fluid3D([11216,10714,11565,11336],0); -ELEMENTS[7122] = Fluid3D([10347,10826,11183,11044],0); -ELEMENTS[7123] = Fluid3D([10446,10347,11183,10135],0); -ELEMENTS[7124] = Fluid3D([10826,9822,10143,9689],0); -ELEMENTS[7125] = Fluid3D([9508,10347,10446,10135],0); -ELEMENTS[7126] = Fluid3D([9822,10446,10714,9717],0); -ELEMENTS[7127] = Fluid3D([11216,11565,11688,12226],0); -ELEMENTS[7128] = Fluid3D([11565,11688,12226,12468],0); -ELEMENTS[7129] = Fluid3D([11565,11688,12468,11183],0); -ELEMENTS[7130] = Fluid3D([11688,11216,12226,11800],0); -ELEMENTS[7131] = Fluid3D([11688,11216,11800,10429],0); -ELEMENTS[7132] = Fluid3D([12226,11688,11800,12555],0); -ELEMENTS[7133] = Fluid3D([12226,11688,12555,12468],0); -ELEMENTS[7134] = Fluid3D([11688,11800,12555,11815],0); -ELEMENTS[7135] = Fluid3D([11688,11800,11815,10429],0); -ELEMENTS[7136] = Fluid3D([9822,9508,10446,9787],0); -ELEMENTS[7137] = Fluid3D([10446,9822,9787,9717],0); -ELEMENTS[7138] = Fluid3D([9822,9787,9717,9169],0); -ELEMENTS[7139] = Fluid3D([10826,10143,11216,10429],0); -ELEMENTS[7140] = Fluid3D([11800,12226,12555,12704],0); -ELEMENTS[7141] = Fluid3D([12226,11565,12468,12689],0); -ELEMENTS[7142] = Fluid3D([11565,12468,12689,12055],0); -ELEMENTS[7143] = Fluid3D([12468,12689,12055,13076],0); -ELEMENTS[7144] = Fluid3D([12468,12689,13076,13585],0); -ELEMENTS[7145] = Fluid3D([12055,12468,13076,12128],0); -ELEMENTS[7146] = Fluid3D([12468,12226,12689,13085],0); -ELEMENTS[7147] = Fluid3D([12689,12055,13076,12876],0); -ELEMENTS[7148] = Fluid3D([13076,12689,12876,13585],0); -ELEMENTS[7149] = Fluid3D([12689,12055,12876,12174],0); -ELEMENTS[7150] = Fluid3D([12689,12055,12174,11565],0); -ELEMENTS[7151] = Fluid3D([12876,12689,12174,13337],0); -ELEMENTS[7152] = Fluid3D([11565,12468,12055,11183],0); -ELEMENTS[7153] = Fluid3D([12055,11565,11183,12174],0); -ELEMENTS[7154] = Fluid3D([12055,12876,12174,12051],0); -ELEMENTS[7155] = Fluid3D([12174,12055,12051,11016],0); -ELEMENTS[7156] = Fluid3D([12055,13076,12876,12745],0); -ELEMENTS[7157] = Fluid3D([13076,12876,12745,13825],0); -ELEMENTS[7158] = Fluid3D([9483,10135,9508,9036],0); -ELEMENTS[7159] = Fluid3D([9483,10135,9036,9502],0); -ELEMENTS[7160] = Fluid3D([12055,12876,12051,12745],0); -ELEMENTS[7161] = Fluid3D([11800,12555,11815,12444],0); -ELEMENTS[7162] = Fluid3D([11815,11800,12444,11475],0); -ELEMENTS[7163] = Fluid3D([11800,12555,12444,12704],0); -ELEMENTS[7164] = Fluid3D([12555,11815,12444,13075],0); -ELEMENTS[7165] = Fluid3D([11815,11800,11475,10429],0); -ELEMENTS[7166] = Fluid3D([11216,12226,11800,11823],0); -ELEMENTS[7167] = Fluid3D([11800,11216,11823,10372],0); -ELEMENTS[7168] = Fluid3D([12226,11800,11823,12704],0); -ELEMENTS[7169] = Fluid3D([11216,12226,11823,11336],0); -ELEMENTS[7170] = Fluid3D([11216,11565,12226,11336],0); -ELEMENTS[7171] = Fluid3D([12555,11688,11815,12260],0); -ELEMENTS[7172] = Fluid3D([12555,11688,12260,12468],0); -ELEMENTS[7173] = Fluid3D([11688,11815,12260,11044],0); -ELEMENTS[7174] = Fluid3D([11815,12555,12260,13075],0); -ELEMENTS[7175] = Fluid3D([11111,10135,10774,11091],0); -ELEMENTS[7176] = Fluid3D([11645,11347,10632,11536],0); -ELEMENTS[7177] = Fluid3D([11645,11347,11536,12409],0); -ELEMENTS[7178] = Fluid3D([11347,10632,11536,10872],0); -ELEMENTS[7179] = Fluid3D([10632,11645,11536,11300],0); -ELEMENTS[7180] = Fluid3D([11645,11536,11300,12212],0); -ELEMENTS[7181] = Fluid3D([10632,11536,10872,10908],0); -ELEMENTS[7182] = Fluid3D([11536,10872,10908,11443],0); -ELEMENTS[7183] = Fluid3D([11536,10872,11443,11857],0); -ELEMENTS[7184] = Fluid3D([11536,10872,11857,11347],0); -ELEMENTS[7185] = Fluid3D([10632,11536,10908,11300],0); -ELEMENTS[7186] = Fluid3D([10872,10632,10908,9901],0); -ELEMENTS[7187] = Fluid3D([10632,10908,9901,9974],0); -ELEMENTS[7188] = Fluid3D([10632,10908,9974,11300],0); -ELEMENTS[7189] = Fluid3D([10872,10632,9901,10359],0); -ELEMENTS[7190] = Fluid3D([10908,9901,9974,9770],0); -ELEMENTS[7191] = Fluid3D([10908,9901,9770,10269],0); -ELEMENTS[7192] = Fluid3D([9901,9974,9770,9086],0); -ELEMENTS[7193] = Fluid3D([9974,10908,9770,10403],0); -ELEMENTS[7194] = Fluid3D([9974,10908,10403,11300],0); -ELEMENTS[7195] = Fluid3D([9901,9974,9086,9551],0); -ELEMENTS[7196] = Fluid3D([9974,9086,9551,9180],0); -ELEMENTS[7197] = Fluid3D([9974,9086,9180,9266],0); -ELEMENTS[7198] = Fluid3D([9974,9086,9266,9770],0); -ELEMENTS[7199] = Fluid3D([9901,9974,9551,10632],0); -ELEMENTS[7200] = Fluid3D([10908,9901,10269,10872],0); -ELEMENTS[7201] = Fluid3D([11347,10632,10872,10359],0); -ELEMENTS[7202] = Fluid3D([10632,11645,11300,10586],0); -ELEMENTS[7203] = Fluid3D([10872,11443,11857,11175],0); -ELEMENTS[7204] = Fluid3D([11857,10872,11175,11208],0); -ELEMENTS[7205] = Fluid3D([10872,11443,11175,10269],0); -ELEMENTS[7206] = Fluid3D([11175,11857,11208,12017],0); -ELEMENTS[7207] = Fluid3D([11857,11208,12017,12149],0); -ELEMENTS[7208] = Fluid3D([11857,11208,12149,11347],0); -ELEMENTS[7209] = Fluid3D([11175,11857,12017,12231],0); -ELEMENTS[7210] = Fluid3D([11175,11857,12231,11443],0); -ELEMENTS[7211] = Fluid3D([11857,12017,12231,12770],0); -ELEMENTS[7212] = Fluid3D([11857,12017,12770,12149],0); -ELEMENTS[7213] = Fluid3D([12017,12231,12770,12787],0); -ELEMENTS[7214] = Fluid3D([12231,12770,12787,13142],0); -ELEMENTS[7215] = Fluid3D([12017,12231,12787,11872],0); -ELEMENTS[7216] = Fluid3D([12017,12231,11872,11175],0); -ELEMENTS[7217] = Fluid3D([12231,12770,13142,12649],0); -ELEMENTS[7218] = Fluid3D([12231,12770,12649,11857],0); -ELEMENTS[7219] = Fluid3D([12770,13142,12649,13495],0); -ELEMENTS[7220] = Fluid3D([13142,12649,13495,13419],0); -ELEMENTS[7221] = Fluid3D([13142,12649,13419,12665],0); -ELEMENTS[7222] = Fluid3D([13142,12649,12665,12231],0); -ELEMENTS[7223] = Fluid3D([12770,13142,13495,13617],0); -ELEMENTS[7224] = Fluid3D([12770,13142,13617,12787],0); -ELEMENTS[7225] = Fluid3D([13142,13495,13617,14024],0); -ELEMENTS[7226] = Fluid3D([13617,13142,14024,13733],0); -ELEMENTS[7227] = Fluid3D([13142,13495,14024,13419],0); -ELEMENTS[7228] = Fluid3D([13617,13142,13733,12787],0); -ELEMENTS[7229] = Fluid3D([11857,10872,11208,11347],0); -ELEMENTS[7230] = Fluid3D([12649,12770,13495,12779],0); -ELEMENTS[7231] = Fluid3D([12649,12770,12779,11857],0); -ELEMENTS[7232] = Fluid3D([13495,12649,12779,13246],0); -ELEMENTS[7233] = Fluid3D([12649,12779,13246,12367],0); -ELEMENTS[7234] = Fluid3D([12770,13495,12779,13399],0); -ELEMENTS[7235] = Fluid3D([12770,13495,13399,13617],0); -ELEMENTS[7236] = Fluid3D([12649,12779,12367,11857],0); -ELEMENTS[7237] = Fluid3D([13495,12649,13246,13419],0); -ELEMENTS[7238] = Fluid3D([12779,13246,12367,12984],0); -ELEMENTS[7239] = Fluid3D([12779,13246,12984,13686],0); -ELEMENTS[7240] = Fluid3D([13246,12367,12984,12212],0); -ELEMENTS[7241] = Fluid3D([12367,12779,12984,12409],0); -ELEMENTS[7242] = Fluid3D([12779,12984,12409,13686],0); -ELEMENTS[7243] = Fluid3D([12367,12779,12409,11857],0); -ELEMENTS[7244] = Fluid3D([12984,12367,12409,12302],0); -ELEMENTS[7245] = Fluid3D([12409,12984,12302,13271],0); -ELEMENTS[7246] = Fluid3D([12779,13246,13686,13495],0); -ELEMENTS[7247] = Fluid3D([13246,12984,13686,13765],0); -ELEMENTS[7248] = Fluid3D([11208,12017,12149,11652],0); -ELEMENTS[7249] = Fluid3D([11208,12017,11652,11007],0); -ELEMENTS[7250] = Fluid3D([12017,12149,11652,12688],0); -ELEMENTS[7251] = Fluid3D([12017,12149,12688,12770],0); -ELEMENTS[7252] = Fluid3D([12017,11652,11007,11944],0); -ELEMENTS[7253] = Fluid3D([12017,11652,11944,12688],0); -ELEMENTS[7254] = Fluid3D([11652,11007,11944,11240],0); -ELEMENTS[7255] = Fluid3D([11007,11944,11240,11280],0); -ELEMENTS[7256] = Fluid3D([11652,11007,11240,10818],0); -ELEMENTS[7257] = Fluid3D([11007,11944,11280,11872],0); -ELEMENTS[7258] = Fluid3D([11652,11007,10818,11208],0); -ELEMENTS[7259] = Fluid3D([12149,11208,11652,11397],0); -ELEMENTS[7260] = Fluid3D([12149,11208,11397,11347],0); -ELEMENTS[7261] = Fluid3D([11208,11652,11397,10818],0); -ELEMENTS[7262] = Fluid3D([11652,12149,11397,12531],0); -ELEMENTS[7263] = Fluid3D([12149,11652,12688,12531],0); -ELEMENTS[7264] = Fluid3D([11208,12017,11007,11175],0); -ELEMENTS[7265] = Fluid3D([12770,12017,12787,12688],0); -ELEMENTS[7266] = Fluid3D([10872,11175,11208,10325],0); -ELEMENTS[7267] = Fluid3D([10872,11175,10325,10269],0); -ELEMENTS[7268] = Fluid3D([11208,10872,10325,10359],0); -ELEMENTS[7269] = Fluid3D([11175,11208,10325,11007],0); -ELEMENTS[7270] = Fluid3D([12302,12128,12736,13271],0); -ELEMENTS[7271] = Fluid3D([12736,12302,13271,12409],0); -ELEMENTS[7272] = Fluid3D([10347,10135,11111,11183],0); -ELEMENTS[7273] = Fluid3D([11111,10347,11183,11044],0); -ELEMENTS[7274] = Fluid3D([11347,11767,11091,12027],0); -ELEMENTS[7275] = Fluid3D([11347,11767,12027,12409],0); -ELEMENTS[7276] = Fluid3D([11767,11091,12027,11918],0); -ELEMENTS[7277] = Fluid3D([12027,11767,11918,12736],0); -ELEMENTS[7278] = Fluid3D([11767,11091,11918,11111],0); -ELEMENTS[7279] = Fluid3D([11091,11347,12027,11397],0); -ELEMENTS[7280] = Fluid3D([12027,11091,11397,11918],0); -ELEMENTS[7281] = Fluid3D([9040,10005,9748,9329],0); -ELEMENTS[7282] = Fluid3D([9751,9337,9505,8522],0); -ELEMENTS[7283] = Fluid3D([4656,4854,4830,4352],0); -ELEMENTS[7284] = Fluid3D([4830,4656,4352,4384],0); -ELEMENTS[7285] = Fluid3D([4656,4854,4352,4441],0); -ELEMENTS[7286] = Fluid3D([4854,4830,4352,4912],0); -ELEMENTS[7287] = Fluid3D([5512,4935,4883,4808],0); -ELEMENTS[7288] = Fluid3D([4883,5512,4808,5058],0); -ELEMENTS[7289] = Fluid3D([5512,4808,5058,5318],0); -ELEMENTS[7290] = Fluid3D([4808,5058,5318,4779],0); -ELEMENTS[7291] = Fluid3D([4808,5058,4779,4466],0); -ELEMENTS[7292] = Fluid3D([4808,5058,4466,4883],0); -ELEMENTS[7293] = Fluid3D([5318,4808,4779,4860],0); -ELEMENTS[7294] = Fluid3D([4808,4779,4860,4360],0); -ELEMENTS[7295] = Fluid3D([5058,5318,4779,5323],0); -ELEMENTS[7296] = Fluid3D([4808,4779,4360,4466],0); -ELEMENTS[7297] = Fluid3D([5318,4808,4860,5193],0); -ELEMENTS[7298] = Fluid3D([5318,4808,5193,5512],0); -ELEMENTS[7299] = Fluid3D([4779,5058,5323,4718],0); -ELEMENTS[7300] = Fluid3D([5058,5318,5323,5929],0); -ELEMENTS[7301] = Fluid3D([4860,4808,4360,4573],0); -ELEMENTS[7302] = Fluid3D([4808,4860,5193,4573],0); -ELEMENTS[7303] = Fluid3D([4808,4360,4573,4323],0); -ELEMENTS[7304] = Fluid3D([4779,4860,4360,4519],0); -ELEMENTS[7305] = Fluid3D([4779,4860,4519,5124],0); -ELEMENTS[7306] = Fluid3D([4779,4860,5124,5318],0); -ELEMENTS[7307] = Fluid3D([4360,4573,4323,4034],0); -ELEMENTS[7308] = Fluid3D([4323,4360,4034,3916],0); -ELEMENTS[7309] = Fluid3D([4323,4360,3916,4466],0); -ELEMENTS[7310] = Fluid3D([4808,4360,4323,4466],0); -ELEMENTS[7311] = Fluid3D([4323,4808,4466,4883],0); -ELEMENTS[7312] = Fluid3D([4360,4779,4519,4269],0); -ELEMENTS[7313] = Fluid3D([4360,4779,4269,4466],0); -ELEMENTS[7314] = Fluid3D([4779,4519,4269,4708],0); -ELEMENTS[7315] = Fluid3D([4779,4519,4708,5124],0); -ELEMENTS[7316] = Fluid3D([4269,4779,4708,4643],0); -ELEMENTS[7317] = Fluid3D([4269,4779,4643,4466],0); -ELEMENTS[7318] = Fluid3D([4519,4360,4269,4003],0); -ELEMENTS[7319] = Fluid3D([4860,5318,5193,5443],0); -ELEMENTS[7320] = Fluid3D([5318,5193,5443,5807],0); -ELEMENTS[7321] = Fluid3D([5318,5193,5807,5512],0); -ELEMENTS[7322] = Fluid3D([4860,5318,5443,5124],0); -ELEMENTS[7323] = Fluid3D([5443,5318,5807,5864],0); -ELEMENTS[7324] = Fluid3D([5443,5318,5864,5124],0); -ELEMENTS[7325] = Fluid3D([5318,5807,5864,5854],0); -ELEMENTS[7326] = Fluid3D([4573,4808,4323,4935],0); -ELEMENTS[7327] = Fluid3D([4360,4860,4573,4380],0); -ELEMENTS[7328] = Fluid3D([4860,4573,4380,4851],0); -ELEMENTS[7329] = Fluid3D([4860,4573,4851,5193],0); -ELEMENTS[7330] = Fluid3D([5318,4779,5323,5124],0); -ELEMENTS[7331] = Fluid3D([4360,4573,4034,4380],0); -ELEMENTS[7332] = Fluid3D([5512,4935,4808,5193],0); -ELEMENTS[7333] = Fluid3D([4935,4808,5193,4573],0); -ELEMENTS[7334] = Fluid3D([4519,4269,4708,4217],0); -ELEMENTS[7335] = Fluid3D([4269,4708,4217,4369],0); -ELEMENTS[7336] = Fluid3D([4269,4708,4369,4643],0); -ELEMENTS[7337] = Fluid3D([4519,4269,4217,4003],0); -ELEMENTS[7338] = Fluid3D([4360,4269,4003,3916],0); -ELEMENTS[7339] = Fluid3D([4860,4360,4519,4380],0); -ELEMENTS[7340] = Fluid3D([4360,4034,3916,4003],0); -ELEMENTS[7341] = Fluid3D([4573,4323,4034,4244],0); -ELEMENTS[7342] = Fluid3D([4323,4034,4244,3855],0); -ELEMENTS[7343] = Fluid3D([4573,4323,4244,4935],0); -ELEMENTS[7344] = Fluid3D([4034,4244,3855,3622],0); -ELEMENTS[7345] = Fluid3D([4034,4573,4244,4291],0); -ELEMENTS[7346] = Fluid3D([4244,4034,4291,3622],0); -ELEMENTS[7347] = Fluid3D([4034,4573,4291,4380],0); -ELEMENTS[7348] = Fluid3D([4323,4034,3855,3916],0); -ELEMENTS[7349] = Fluid3D([4573,4244,4291,4681],0); -ELEMENTS[7350] = Fluid3D([4244,4291,4681,4226],0); -ELEMENTS[7351] = Fluid3D([4573,4244,4681,4935],0); -ELEMENTS[7352] = Fluid3D([4291,4681,4226,4523],0); -ELEMENTS[7353] = Fluid3D([4291,4681,4523,4851],0); -ELEMENTS[7354] = Fluid3D([4681,4226,4523,4537],0); -ELEMENTS[7355] = Fluid3D([4244,4291,4226,3622],0); -ELEMENTS[7356] = Fluid3D([4226,4291,4523,3741],0); -ELEMENTS[7357] = Fluid3D([4291,4573,4681,4851],0); -ELEMENTS[7358] = Fluid3D([4244,4323,3855,4334],0); -ELEMENTS[7359] = Fluid3D([4244,4323,4334,4935],0); -ELEMENTS[7360] = Fluid3D([4323,3855,4334,4202],0); -ELEMENTS[7361] = Fluid3D([4323,3855,4202,3916],0); -ELEMENTS[7362] = Fluid3D([4334,4323,4202,4883],0); -ELEMENTS[7363] = Fluid3D([3855,4334,4202,3784],0); -ELEMENTS[7364] = Fluid3D([4202,3855,3784,3559],0); -ELEMENTS[7365] = Fluid3D([3855,4334,3784,3934],0); -ELEMENTS[7366] = Fluid3D([3855,4334,3934,4244],0); -ELEMENTS[7367] = Fluid3D([4334,4202,3784,4180],0); -ELEMENTS[7368] = Fluid3D([4202,3784,4180,3768],0); -ELEMENTS[7369] = Fluid3D([4202,3784,3768,3559],0); -ELEMENTS[7370] = Fluid3D([4334,4202,4180,4474],0); -ELEMENTS[7371] = Fluid3D([4334,4202,4474,4883],0); -ELEMENTS[7372] = Fluid3D([4202,4180,4474,4343],0); -ELEMENTS[7373] = Fluid3D([4202,4180,4343,3768],0); -ELEMENTS[7374] = Fluid3D([4180,4474,4343,4531],0); -ELEMENTS[7375] = Fluid3D([4180,4474,4531,4334],0); -ELEMENTS[7376] = Fluid3D([4343,4180,4531,4337],0); -ELEMENTS[7377] = Fluid3D([4180,4531,4337,4500],0); -ELEMENTS[7378] = Fluid3D([4531,4180,4334,4241],0); -ELEMENTS[7379] = Fluid3D([4531,4180,4241,4500],0); -ELEMENTS[7380] = Fluid3D([4180,4334,4241,3784],0); -ELEMENTS[7381] = Fluid3D([4202,3855,3559,3916],0); -ELEMENTS[7382] = Fluid3D([4935,4883,4808,4323],0); -ELEMENTS[7383] = Fluid3D([3855,3784,3559,3451],0); -ELEMENTS[7384] = Fluid3D([3855,3784,3451,3934],0); -ELEMENTS[7385] = Fluid3D([3559,3855,3451,3462],0); -ELEMENTS[7386] = Fluid3D([3559,3855,3462,3916],0); -ELEMENTS[7387] = Fluid3D([3451,3559,3462,3147],0); -ELEMENTS[7388] = Fluid3D([3559,3462,3147,3327],0); -ELEMENTS[7389] = Fluid3D([3559,3462,3327,3916],0); -ELEMENTS[7390] = Fluid3D([3784,3559,3451,3355],0); -ELEMENTS[7391] = Fluid3D([3559,3451,3355,3147],0); -ELEMENTS[7392] = Fluid3D([3784,3559,3355,3768],0); -ELEMENTS[7393] = Fluid3D([3855,3451,3462,3622],0); -ELEMENTS[7394] = Fluid3D([3855,3451,3622,3934],0); -ELEMENTS[7395] = Fluid3D([3451,3622,3934,3617],0); -ELEMENTS[7396] = Fluid3D([3622,3934,3617,3941],0); -ELEMENTS[7397] = Fluid3D([3622,3855,3934,4244],0); -ELEMENTS[7398] = Fluid3D([3451,3462,3622,3237],0); -ELEMENTS[7399] = Fluid3D([3622,3451,3237,3617],0); -ELEMENTS[7400] = Fluid3D([3934,3617,3941,4086],0); -ELEMENTS[7401] = Fluid3D([3462,3147,3327,3087],0); -ELEMENTS[7402] = Fluid3D([3462,3147,3087,3133],0); -ELEMENTS[7403] = Fluid3D([3147,3087,3133,2820],0); -ELEMENTS[7404] = Fluid3D([3147,3327,3087,2932],0); -ELEMENTS[7405] = Fluid3D([3147,3087,2820,2932],0); -ELEMENTS[7406] = Fluid3D([3147,3327,2932,3180],0); -ELEMENTS[7407] = Fluid3D([3327,2932,3180,3136],0); -ELEMENTS[7408] = Fluid3D([3327,2932,3136,3074],0); -ELEMENTS[7409] = Fluid3D([3327,2932,3074,3087],0); -ELEMENTS[7410] = Fluid3D([3147,3327,3180,3559],0); -ELEMENTS[7411] = Fluid3D([3327,3462,3087,3431],0); -ELEMENTS[7412] = Fluid3D([3327,3462,3431,3916],0); -ELEMENTS[7413] = Fluid3D([3462,3087,3431,3318],0); -ELEMENTS[7414] = Fluid3D([3462,3087,3318,3133],0); -ELEMENTS[7415] = Fluid3D([3087,3327,3431,3074],0); -ELEMENTS[7416] = Fluid3D([3462,3147,3133,3237],0); -ELEMENTS[7417] = Fluid3D([3087,3431,3318,3106],0); -ELEMENTS[7418] = Fluid3D([3431,3318,3106,3494],0); -ELEMENTS[7419] = Fluid3D([3318,3106,3494,3178],0); -ELEMENTS[7420] = Fluid3D([3318,3106,3178,2910],0); -ELEMENTS[7421] = Fluid3D([3318,3106,2910,3087],0); -ELEMENTS[7422] = Fluid3D([3087,3431,3106,3074],0); -ELEMENTS[7423] = Fluid3D([3494,3318,3178,3505],0); -ELEMENTS[7424] = Fluid3D([3494,3318,3505,3772],0); -ELEMENTS[7425] = Fluid3D([3494,3318,3772,3431],0); -ELEMENTS[7426] = Fluid3D([3318,3178,3505,3172],0); -ELEMENTS[7427] = Fluid3D([3318,3178,3172,2910],0); -ELEMENTS[7428] = Fluid3D([3318,3505,3772,3512],0); -ELEMENTS[7429] = Fluid3D([3505,3318,3172,3512],0); -ELEMENTS[7430] = Fluid3D([3505,3772,3512,3978],0); -ELEMENTS[7431] = Fluid3D([3512,3505,3978,3741],0); -ELEMENTS[7432] = Fluid3D([3978,3512,3741,4291],0); -ELEMENTS[7433] = Fluid3D([3978,3512,4291,4034],0); -ELEMENTS[7434] = Fluid3D([4291,3978,4034,4380],0); -ELEMENTS[7435] = Fluid3D([4291,3978,4380,4453],0); -ELEMENTS[7436] = Fluid3D([4291,3978,4453,4140],0); -ELEMENTS[7437] = Fluid3D([4291,3978,4140,3741],0); -ELEMENTS[7438] = Fluid3D([3978,4453,4140,4032],0); -ELEMENTS[7439] = Fluid3D([4140,3978,4032,3473],0); -ELEMENTS[7440] = Fluid3D([4140,3978,3473,3741],0); -ELEMENTS[7441] = Fluid3D([3473,4140,3741,3799],0); -ELEMENTS[7442] = Fluid3D([4453,4291,4140,4523],0); -ELEMENTS[7443] = Fluid3D([4291,4140,4523,3741],0); -ELEMENTS[7444] = Fluid3D([4140,4453,4523,4520],0); -ELEMENTS[7445] = Fluid3D([4523,4140,4520,4240],0); -ELEMENTS[7446] = Fluid3D([3978,4453,4032,4136],0); -ELEMENTS[7447] = Fluid3D([3978,3473,3741,3505],0); -ELEMENTS[7448] = Fluid3D([4523,4140,4240,3741],0); -ELEMENTS[7449] = Fluid3D([3978,4453,4136,4380],0); -ELEMENTS[7450] = Fluid3D([3978,3473,3505,4032],0); -ELEMENTS[7451] = Fluid3D([4032,3978,4136,3505],0); -ELEMENTS[7452] = Fluid3D([4032,4140,3473,4159],0); -ELEMENTS[7453] = Fluid3D([4453,4032,4136,4444],0); -ELEMENTS[7454] = Fluid3D([4136,4453,4444,4690],0); -ELEMENTS[7455] = Fluid3D([4453,4444,4690,4956],0); -ELEMENTS[7456] = Fluid3D([4453,4032,4444,4520],0); -ELEMENTS[7457] = Fluid3D([4453,4444,4956,4520],0); -ELEMENTS[7458] = Fluid3D([4690,4453,4956,4851],0); -ELEMENTS[7459] = Fluid3D([4690,4453,4851,4380],0); -ELEMENTS[7460] = Fluid3D([4851,4690,4380,4860],0); -ELEMENTS[7461] = Fluid3D([4136,4453,4690,4380],0); -ELEMENTS[7462] = Fluid3D([4690,4136,4380,4362],0); -ELEMENTS[7463] = Fluid3D([4136,4380,4362,4003],0); -ELEMENTS[7464] = Fluid3D([4380,4690,4362,4860],0); -ELEMENTS[7465] = Fluid3D([4690,4136,4362,4391],0); -ELEMENTS[7466] = Fluid3D([4136,4362,4391,3926],0); -ELEMENTS[7467] = Fluid3D([4136,4362,3926,4003],0); -ELEMENTS[7468] = Fluid3D([4391,4136,3926,3955],0); -ELEMENTS[7469] = Fluid3D([4136,3926,3955,3505],0); -ELEMENTS[7470] = Fluid3D([4362,4391,3926,4319],0); -ELEMENTS[7471] = Fluid3D([3926,4362,4319,4014],0); -ELEMENTS[7472] = Fluid3D([3926,4362,4014,4003],0); -ELEMENTS[7473] = Fluid3D([4690,4136,4391,4444],0); -ELEMENTS[7474] = Fluid3D([4136,4391,4444,3955],0); -ELEMENTS[7475] = Fluid3D([4391,4690,4444,4914],0); -ELEMENTS[7476] = Fluid3D([4444,4391,4914,4585],0); -ELEMENTS[7477] = Fluid3D([4444,4391,4585,3955],0); -ELEMENTS[7478] = Fluid3D([4914,4444,4585,4827],0); -ELEMENTS[7479] = Fluid3D([4391,4914,4585,4723],0); -ELEMENTS[7480] = Fluid3D([4914,4444,4827,4956],0); -ELEMENTS[7481] = Fluid3D([4391,4914,4723,4879],0); -ELEMENTS[7482] = Fluid3D([4362,4391,4319,4879],0); -ELEMENTS[7483] = Fluid3D([4914,4723,4879,5295],0); -ELEMENTS[7484] = Fluid3D([4879,4914,5295,5369],0); -ELEMENTS[7485] = Fluid3D([4879,4914,5369,4690],0); -ELEMENTS[7486] = Fluid3D([4391,4914,4879,4690],0); -ELEMENTS[7487] = Fluid3D([4690,4444,4914,4956],0); -ELEMENTS[7488] = Fluid3D([4444,4585,4827,4286],0); -ELEMENTS[7489] = Fluid3D([4444,4585,4286,3955],0); -ELEMENTS[7490] = Fluid3D([4827,4444,4286,4567],0); -ELEMENTS[7491] = Fluid3D([4827,4444,4567,4956],0); -ELEMENTS[7492] = Fluid3D([4444,4286,4567,4032],0); -ELEMENTS[7493] = Fluid3D([4585,4827,4286,4610],0); -ELEMENTS[7494] = Fluid3D([4286,4585,4610,4094],0); -ELEMENTS[7495] = Fluid3D([4286,4585,4094,3955],0); -ELEMENTS[7496] = Fluid3D([4585,4827,4610,5223],0); -ELEMENTS[7497] = Fluid3D([4723,4391,4879,4319],0); -ELEMENTS[7498] = Fluid3D([4032,4136,4444,3955],0); -ELEMENTS[7499] = Fluid3D([4585,4391,4723,4237],0); -ELEMENTS[7500] = Fluid3D([4585,4391,4237,3955],0); -ELEMENTS[7501] = Fluid3D([4391,4723,4237,4319],0); -ELEMENTS[7502] = Fluid3D([4723,4585,4237,4451],0); -ELEMENTS[7503] = Fluid3D([4723,4585,4451,5223],0); -ELEMENTS[7504] = Fluid3D([4585,4237,4451,4094],0); -ELEMENTS[7505] = Fluid3D([4362,4319,4014,4536],0); -ELEMENTS[7506] = Fluid3D([3772,3512,3978,4034],0); -ELEMENTS[7507] = Fluid3D([3978,3772,4034,4380],0); -ELEMENTS[7508] = Fluid3D([3772,3512,4034,3462],0); -ELEMENTS[7509] = Fluid3D([3505,3772,3978,4136],0); -ELEMENTS[7510] = Fluid3D([4453,4140,4032,4520],0); -ELEMENTS[7511] = Fluid3D([3106,3431,3494,3378],0); -ELEMENTS[7512] = Fluid3D([3431,3494,3378,4003],0); -ELEMENTS[7513] = Fluid3D([3494,3106,3378,3208],0); -ELEMENTS[7514] = Fluid3D([3494,3106,3208,3178],0); -ELEMENTS[7515] = Fluid3D([3378,3494,3208,3629],0); -ELEMENTS[7516] = Fluid3D([3378,3494,3629,4003],0); -ELEMENTS[7517] = Fluid3D([3106,3431,3378,3074],0); -ELEMENTS[7518] = Fluid3D([3494,3208,3629,3522],0); -ELEMENTS[7519] = Fluid3D([3494,3208,3522,3178],0); -ELEMENTS[7520] = Fluid3D([3629,3494,3522,3926],0); -ELEMENTS[7521] = Fluid3D([3522,3629,3926,3680],0); -ELEMENTS[7522] = Fluid3D([3926,3522,3680,3955],0); -ELEMENTS[7523] = Fluid3D([3522,3629,3680,3208],0); -ELEMENTS[7524] = Fluid3D([3629,3926,3680,4014],0); -ELEMENTS[7525] = Fluid3D([3629,3926,4014,4003],0); -ELEMENTS[7526] = Fluid3D([3178,3494,3505,3522],0); -ELEMENTS[7527] = Fluid3D([3178,3505,3172,3336],0); -ELEMENTS[7528] = Fluid3D([3172,3178,3336,2953],0); -ELEMENTS[7529] = Fluid3D([3178,3505,3336,3522],0); -ELEMENTS[7530] = Fluid3D([3336,3172,2953,3169],0); -ELEMENTS[7531] = Fluid3D([3505,3172,3336,3473],0); -ELEMENTS[7532] = Fluid3D([3172,2953,3169,2949],0); -ELEMENTS[7533] = Fluid3D([3172,2953,2949,2910],0); -ELEMENTS[7534] = Fluid3D([3336,3172,3169,3473],0); -ELEMENTS[7535] = Fluid3D([2953,3169,2949,2793],0); -ELEMENTS[7536] = Fluid3D([2949,2953,2793,2598],0); -ELEMENTS[7537] = Fluid3D([2949,2953,2598,2910],0); -ELEMENTS[7538] = Fluid3D([2953,3169,2793,3022],0); -ELEMENTS[7539] = Fluid3D([2953,3169,3022,3336],0); -ELEMENTS[7540] = Fluid3D([3169,2949,2793,2935],0); -ELEMENTS[7541] = Fluid3D([2949,2793,2935,2618],0); -ELEMENTS[7542] = Fluid3D([2949,2793,2618,2598],0); -ELEMENTS[7543] = Fluid3D([3169,2793,3022,3019],0); -ELEMENTS[7544] = Fluid3D([3022,3169,3019,3388],0); -ELEMENTS[7545] = Fluid3D([3022,3169,3388,3336],0); -ELEMENTS[7546] = Fluid3D([3169,2949,2935,3260],0); -ELEMENTS[7547] = Fluid3D([3169,2793,3019,2935],0); -ELEMENTS[7548] = Fluid3D([3172,3178,2953,2910],0); -ELEMENTS[7549] = Fluid3D([3178,3336,2953,3082],0); -ELEMENTS[7550] = Fluid3D([3178,3336,3082,3522],0); -ELEMENTS[7551] = Fluid3D([2953,3178,3082,2823],0); -ELEMENTS[7552] = Fluid3D([3178,3082,2823,3208],0); -ELEMENTS[7553] = Fluid3D([3336,2953,3082,3022],0); -ELEMENTS[7554] = Fluid3D([2953,3178,2823,2910],0); -ELEMENTS[7555] = Fluid3D([3106,3378,3208,2980],0); -ELEMENTS[7556] = Fluid3D([3208,3106,2980,2823],0); -ELEMENTS[7557] = Fluid3D([3378,3208,2980,3252],0); -ELEMENTS[7558] = Fluid3D([3208,2980,3252,2947],0); -ELEMENTS[7559] = Fluid3D([3208,2980,2947,2823],0); -ELEMENTS[7560] = Fluid3D([3106,3378,2980,3074],0); -ELEMENTS[7561] = Fluid3D([3252,3208,2947,3304],0); -ELEMENTS[7562] = Fluid3D([3252,3208,3304,3629],0); -ELEMENTS[7563] = Fluid3D([3208,2947,3304,3052],0); -ELEMENTS[7564] = Fluid3D([3208,2947,3052,2823],0); -ELEMENTS[7565] = Fluid3D([2947,3252,3304,3122],0); -ELEMENTS[7566] = Fluid3D([3252,3304,3122,3546],0); -ELEMENTS[7567] = Fluid3D([3252,3304,3546,3629],0); -ELEMENTS[7568] = Fluid3D([2947,3304,3052,2995],0); -ELEMENTS[7569] = Fluid3D([2947,3252,3122,2920],0); -ELEMENTS[7570] = Fluid3D([2947,3304,2995,3122],0); -ELEMENTS[7571] = Fluid3D([2947,3252,2920,2980],0); -ELEMENTS[7572] = Fluid3D([3304,3052,2995,3288],0); -ELEMENTS[7573] = Fluid3D([3052,2995,3288,2943],0); -ELEMENTS[7574] = Fluid3D([3052,2995,2943,2713],0); -ELEMENTS[7575] = Fluid3D([3052,2995,2713,2947],0); -ELEMENTS[7576] = Fluid3D([3304,3052,3288,3457],0); -ELEMENTS[7577] = Fluid3D([3304,3052,3457,3208],0); -ELEMENTS[7578] = Fluid3D([3052,3288,3457,3216],0); -ELEMENTS[7579] = Fluid3D([3052,3288,3216,2943],0); -ELEMENTS[7580] = Fluid3D([2995,3288,2943,3057],0); -ELEMENTS[7581] = Fluid3D([2943,2995,3057,2740],0); -ELEMENTS[7582] = Fluid3D([2943,2995,2740,2713],0); -ELEMENTS[7583] = Fluid3D([2995,3288,3057,3334],0); -ELEMENTS[7584] = Fluid3D([2995,3288,3334,3304],0); -ELEMENTS[7585] = Fluid3D([3288,3457,3216,3625],0); -ELEMENTS[7586] = Fluid3D([3288,3057,3334,3501],0); -ELEMENTS[7587] = Fluid3D([3457,3216,3625,3577],0); -ELEMENTS[7588] = Fluid3D([3288,3057,3501,3245],0); -ELEMENTS[7589] = Fluid3D([3288,3057,3245,2943],0); -ELEMENTS[7590] = Fluid3D([3457,3216,3577,3082],0); -ELEMENTS[7591] = Fluid3D([3457,3216,3082,3052],0); -ELEMENTS[7592] = Fluid3D([3216,3082,3052,2943],0); -ELEMENTS[7593] = Fluid3D([3216,3577,3082,3211],0); -ELEMENTS[7594] = Fluid3D([3082,3216,3211,2905],0); -ELEMENTS[7595] = Fluid3D([3082,3216,2905,2943],0); -ELEMENTS[7596] = Fluid3D([3216,3211,2905,3168],0); -ELEMENTS[7597] = Fluid3D([3216,3211,3168,3556],0); -ELEMENTS[7598] = Fluid3D([3216,3211,3556,3577],0); -ELEMENTS[7599] = Fluid3D([3556,3216,3577,3625],0); -ELEMENTS[7600] = Fluid3D([3577,3556,3625,4094],0); -ELEMENTS[7601] = Fluid3D([3556,3216,3625,3245],0); -ELEMENTS[7602] = Fluid3D([3211,3556,3577,3643],0); -ELEMENTS[7603] = Fluid3D([3556,3577,3643,4094],0); -ELEMENTS[7604] = Fluid3D([2905,3216,3168,2943],0); -ELEMENTS[7605] = Fluid3D([3168,3216,3556,3245],0); -ELEMENTS[7606] = Fluid3D([3211,3556,3643,3437],0); -ELEMENTS[7607] = Fluid3D([3556,3643,3437,3834],0); -ELEMENTS[7608] = Fluid3D([3556,3643,3834,4094],0); -ELEMENTS[7609] = Fluid3D([3834,3556,4094,3720],0); -ELEMENTS[7610] = Fluid3D([4094,3834,3720,4183],0); -ELEMENTS[7611] = Fluid3D([4094,3834,4183,4610],0); -ELEMENTS[7612] = Fluid3D([3834,3720,4183,3647],0); -ELEMENTS[7613] = Fluid3D([3834,3720,3647,3437],0); -ELEMENTS[7614] = Fluid3D([4183,3834,3647,4101],0); -ELEMENTS[7615] = Fluid3D([4183,3834,4101,4610],0); -ELEMENTS[7616] = Fluid3D([3834,3647,4101,3437],0); -ELEMENTS[7617] = Fluid3D([3720,4094,4183,4221],0); -ELEMENTS[7618] = Fluid3D([4094,4183,4221,4610],0); -ELEMENTS[7619] = Fluid3D([3834,3556,3720,3437],0); -ELEMENTS[7620] = Fluid3D([3211,3082,2905,3022],0); -ELEMENTS[7621] = Fluid3D([2905,3211,3022,2997],0); -ELEMENTS[7622] = Fluid3D([3211,3022,2997,3388],0); -ELEMENTS[7623] = Fluid3D([3211,3022,3388,3336],0); -ELEMENTS[7624] = Fluid3D([3211,3022,3336,3082],0); -ELEMENTS[7625] = Fluid3D([3211,3556,3437,3168],0); -ELEMENTS[7626] = Fluid3D([3720,4094,4221,3883],0); -ELEMENTS[7627] = Fluid3D([4094,4221,3883,4451],0); -ELEMENTS[7628] = Fluid3D([3720,4183,3647,3893],0); -ELEMENTS[7629] = Fluid3D([3647,3720,3893,3480],0); -ELEMENTS[7630] = Fluid3D([3647,3720,3480,3437],0); -ELEMENTS[7631] = Fluid3D([4183,3647,3893,4130],0); -ELEMENTS[7632] = Fluid3D([4183,3647,4130,4101],0); -ELEMENTS[7633] = Fluid3D([3647,3893,4130,3668],0); -ELEMENTS[7634] = Fluid3D([3647,3893,3668,3480],0); -ELEMENTS[7635] = Fluid3D([3211,2905,3168,2997],0); -ELEMENTS[7636] = Fluid3D([3168,3211,2997,3437],0); -ELEMENTS[7637] = Fluid3D([3211,2997,3437,3388],0); -ELEMENTS[7638] = Fluid3D([4130,3647,3668,3789],0); -ELEMENTS[7639] = Fluid3D([4130,3647,3789,4101],0); -ELEMENTS[7640] = Fluid3D([3643,3437,3834,3675],0); -ELEMENTS[7641] = Fluid3D([3834,3643,3675,4286],0); -ELEMENTS[7642] = Fluid3D([3643,3437,3675,3388],0); -ELEMENTS[7643] = Fluid3D([3720,4094,3883,3625],0); -ELEMENTS[7644] = Fluid3D([3288,3457,3625,3680],0); -ELEMENTS[7645] = Fluid3D([3288,3457,3680,3304],0); -ELEMENTS[7646] = Fluid3D([3457,3680,3304,3208],0); -ELEMENTS[7647] = Fluid3D([4183,3720,4221,3893],0); -ELEMENTS[7648] = Fluid3D([3556,3437,3168,3720],0); -ELEMENTS[7649] = Fluid3D([3378,3208,3252,3629],0); -ELEMENTS[7650] = Fluid3D([3082,2953,2823,2770],0); -ELEMENTS[7651] = Fluid3D([2953,2823,2770,2598],0); -ELEMENTS[7652] = Fluid3D([3082,2953,2770,3022],0); -ELEMENTS[7653] = Fluid3D([2823,3082,2770,3052],0); -ELEMENTS[7654] = Fluid3D([2980,3378,3252,3176],0); -ELEMENTS[7655] = Fluid3D([3378,3252,3176,3596],0); -ELEMENTS[7656] = Fluid3D([3252,3176,3596,3313],0); -ELEMENTS[7657] = Fluid3D([3252,3176,3313,2920],0); -ELEMENTS[7658] = Fluid3D([2980,3378,3176,3074],0); -ELEMENTS[7659] = Fluid3D([3176,3596,3313,3469],0); -ELEMENTS[7660] = Fluid3D([3313,3176,3469,3036],0); -ELEMENTS[7661] = Fluid3D([3313,3176,3036,2920],0); -ELEMENTS[7662] = Fluid3D([3596,3313,3469,3760],0); -ELEMENTS[7663] = Fluid3D([3596,3313,3760,3546],0); -ELEMENTS[7664] = Fluid3D([3313,3469,3760,3440],0); -ELEMENTS[7665] = Fluid3D([3313,3469,3440,3036],0); -ELEMENTS[7666] = Fluid3D([3176,3596,3469,3507],0); -ELEMENTS[7667] = Fluid3D([3596,3469,3507,3890],0); -ELEMENTS[7668] = Fluid3D([3469,3760,3440,3805],0); -ELEMENTS[7669] = Fluid3D([3176,3596,3507,3378],0); -ELEMENTS[7670] = Fluid3D([3596,3469,3890,3760],0); -ELEMENTS[7671] = Fluid3D([3469,3760,3805,3890],0); -ELEMENTS[7672] = Fluid3D([3378,3252,3596,3629],0); -ELEMENTS[7673] = Fluid3D([3252,2980,3176,2920],0); -ELEMENTS[7674] = Fluid3D([4681,4244,4226,4527],0); -ELEMENTS[7675] = Fluid3D([4681,4244,4527,4935],0); -ELEMENTS[7676] = Fluid3D([4244,4226,4527,3934],0); -ELEMENTS[7677] = Fluid3D([4226,4681,4527,4537],0); -ELEMENTS[7678] = Fluid3D([4527,4226,4537,4086],0); -ELEMENTS[7679] = Fluid3D([3462,3451,3147,3237],0); -ELEMENTS[7680] = Fluid3D([3431,3462,3318,3772],0); -ELEMENTS[7681] = Fluid3D([5193,4860,5443,4851],0); -ELEMENTS[7682] = Fluid3D([4860,4519,5124,4880],0); -ELEMENTS[7683] = Fluid3D([5124,4860,4880,5443],0); -ELEMENTS[7684] = Fluid3D([4519,5124,4880,4536],0); -ELEMENTS[7685] = Fluid3D([4860,4519,4880,4362],0); -ELEMENTS[7686] = Fluid3D([4519,4880,4362,4536],0); -ELEMENTS[7687] = Fluid3D([4362,4519,4536,4014],0); -ELEMENTS[7688] = Fluid3D([4334,3784,3934,4241],0); -ELEMENTS[7689] = Fluid3D([4519,4360,4003,4380],0); -ELEMENTS[7690] = Fluid3D([4779,4708,4643,5323],0); -ELEMENTS[7691] = Fluid3D([3451,3784,3355,3605],0); -ELEMENTS[7692] = Fluid3D([3451,3784,3605,3934],0); -ELEMENTS[7693] = Fluid3D([3355,3451,3605,3113],0); -ELEMENTS[7694] = Fluid3D([3355,3451,3113,3147],0); -ELEMENTS[7695] = Fluid3D([3784,3355,3605,3640],0); -ELEMENTS[7696] = Fluid3D([3605,3355,3113,3184],0); -ELEMENTS[7697] = Fluid3D([3355,3113,3184,2940],0); -ELEMENTS[7698] = Fluid3D([3355,3605,3640,3184],0); -ELEMENTS[7699] = Fluid3D([3113,3184,2940,2842],0); -ELEMENTS[7700] = Fluid3D([3113,3184,2842,3129],0); -ELEMENTS[7701] = Fluid3D([3113,3184,3129,3605],0); -ELEMENTS[7702] = Fluid3D([2940,3113,2842,2762],0); -ELEMENTS[7703] = Fluid3D([2940,3113,2762,3147],0); -ELEMENTS[7704] = Fluid3D([2842,2940,2762,2615],0); -ELEMENTS[7705] = Fluid3D([2940,2762,2615,2721],0); -ELEMENTS[7706] = Fluid3D([2940,2762,2721,3147],0); -ELEMENTS[7707] = Fluid3D([2842,2940,2615,2845],0); -ELEMENTS[7708] = Fluid3D([2842,2940,2845,3184],0); -ELEMENTS[7709] = Fluid3D([2940,2615,2845,2630],0); -ELEMENTS[7710] = Fluid3D([2615,2842,2845,2583],0); -ELEMENTS[7711] = Fluid3D([2842,2845,2583,2892],0); -ELEMENTS[7712] = Fluid3D([2842,2845,2892,3184],0); -ELEMENTS[7713] = Fluid3D([2845,2583,2892,2607],0); -ELEMENTS[7714] = Fluid3D([2615,2842,2583,2535],0); -ELEMENTS[7715] = Fluid3D([2842,2583,2535,2687],0); -ELEMENTS[7716] = Fluid3D([2842,2583,2687,2892],0); -ELEMENTS[7717] = Fluid3D([2615,2842,2535,2762],0); -ELEMENTS[7718] = Fluid3D([2583,2615,2535,2241],0); -ELEMENTS[7719] = Fluid3D([3355,3113,2940,3147],0); -ELEMENTS[7720] = Fluid3D([2842,3113,3129,2872],0); -ELEMENTS[7721] = Fluid3D([2842,3113,2872,2762],0); -ELEMENTS[7722] = Fluid3D([3113,3129,2872,3237],0); -ELEMENTS[7723] = Fluid3D([3129,2842,2872,2687],0); -ELEMENTS[7724] = Fluid3D([2845,2615,2583,2487],0); -ELEMENTS[7725] = Fluid3D([2583,2845,2487,2607],0); -ELEMENTS[7726] = Fluid3D([2615,2583,2487,2241],0); -ELEMENTS[7727] = Fluid3D([2487,2583,2607,2355],0); -ELEMENTS[7728] = Fluid3D([2487,2583,2355,2241],0); -ELEMENTS[7729] = Fluid3D([3451,3605,3113,3237],0); -ELEMENTS[7730] = Fluid3D([3113,3451,3237,3147],0); -ELEMENTS[7731] = Fluid3D([3605,3784,3640,4241],0); -ELEMENTS[7732] = Fluid3D([3184,3355,2940,3191],0); -ELEMENTS[7733] = Fluid3D([3355,2940,3191,3180],0); -ELEMENTS[7734] = Fluid3D([3184,3355,3191,3640],0); -ELEMENTS[7735] = Fluid3D([2940,3184,3191,2845],0); -ELEMENTS[7736] = Fluid3D([3784,3355,3640,3768],0); -ELEMENTS[7737] = Fluid3D([2762,2615,2721,2466],0); -ELEMENTS[7738] = Fluid3D([2762,2615,2466,2535],0); -ELEMENTS[7739] = Fluid3D([2615,2721,2466,2374],0); -ELEMENTS[7740] = Fluid3D([2721,2762,2466,2820],0); -ELEMENTS[7741] = Fluid3D([3184,2842,3129,2892],0); -ELEMENTS[7742] = Fluid3D([2615,2940,2721,2816],0); -ELEMENTS[7743] = Fluid3D([2615,2940,2816,2630],0); -ELEMENTS[7744] = Fluid3D([2940,2721,2816,3180],0); -ELEMENTS[7745] = Fluid3D([2721,2615,2816,2374],0); -ELEMENTS[7746] = Fluid3D([5193,5443,5807,5665],0); -ELEMENTS[7747] = Fluid3D([5807,5193,5665,5549],0); -ELEMENTS[7748] = Fluid3D([5193,5443,5665,4851],0); -ELEMENTS[7749] = Fluid3D([5443,5807,5665,6101],0); -ELEMENTS[7750] = Fluid3D([5807,5665,6101,6268],0); -ELEMENTS[7751] = Fluid3D([5665,5443,6101,5711],0); -ELEMENTS[7752] = Fluid3D([5665,6101,6268,6214],0); -ELEMENTS[7753] = Fluid3D([5443,5807,6101,5864],0); -ELEMENTS[7754] = Fluid3D([5443,6101,5711,5822],0); -ELEMENTS[7755] = Fluid3D([6101,6268,6214,6771],0); -ELEMENTS[7756] = Fluid3D([6268,6214,6771,6084],0); -ELEMENTS[7757] = Fluid3D([6101,6268,6771,6580],0); -ELEMENTS[7758] = Fluid3D([6268,6771,6580,7027],0); -ELEMENTS[7759] = Fluid3D([6268,6771,7027,6084],0); -ELEMENTS[7760] = Fluid3D([6771,6580,7027,7279],0); -ELEMENTS[7761] = Fluid3D([6580,7027,7279,7154],0); -ELEMENTS[7762] = Fluid3D([6771,6580,7279,6697],0); -ELEMENTS[7763] = Fluid3D([6580,7279,6697,6828],0); -ELEMENTS[7764] = Fluid3D([6580,7279,6828,7154],0); -ELEMENTS[7765] = Fluid3D([6697,6580,6828,5864],0); -ELEMENTS[7766] = Fluid3D([6580,6268,7027,6313],0); -ELEMENTS[7767] = Fluid3D([7027,6580,6313,7154],0); -ELEMENTS[7768] = Fluid3D([6214,6101,6771,6461],0); -ELEMENTS[7769] = Fluid3D([6771,6214,6461,7105],0); -ELEMENTS[7770] = Fluid3D([6771,6580,6697,6101],0); -ELEMENTS[7771] = Fluid3D([6580,6697,6101,5864],0); -ELEMENTS[7772] = Fluid3D([6697,6771,6101,6461],0); -ELEMENTS[7773] = Fluid3D([6101,6697,6461,5822],0); -ELEMENTS[7774] = Fluid3D([6580,6268,6313,5807],0); -ELEMENTS[7775] = Fluid3D([6697,6771,6461,7509],0); -ELEMENTS[7776] = Fluid3D([7279,6697,6828,7706],0); -ELEMENTS[7777] = Fluid3D([6101,6268,6580,5807],0); -ELEMENTS[7778] = Fluid3D([6214,6101,6461,5711],0); -ELEMENTS[7779] = Fluid3D([6101,5711,5822,6461],0); -ELEMENTS[7780] = Fluid3D([5665,6101,6214,5711],0); -ELEMENTS[7781] = Fluid3D([5443,6101,5822,5864],0); -ELEMENTS[7782] = Fluid3D([5807,5665,6268,5549],0); -ELEMENTS[7783] = Fluid3D([5665,5443,5711,4851],0); -ELEMENTS[7784] = Fluid3D([5711,5443,5822,5369],0); -ELEMENTS[7785] = Fluid3D([6268,5665,6214,6084],0); -ELEMENTS[7786] = Fluid3D([10138,9373,10167,9838],0); -ELEMENTS[7787] = Fluid3D([9373,10167,9838,9083],0); -ELEMENTS[7788] = Fluid3D([10167,10138,9838,10773],0); -ELEMENTS[7789] = Fluid3D([9838,10167,10773,10103],0); -ELEMENTS[7790] = Fluid3D([10167,10773,10103,10820],0); -ELEMENTS[7791] = Fluid3D([10167,10773,10820,11055],0); -ELEMENTS[7792] = Fluid3D([10167,10773,11055,11046],0); -ELEMENTS[7793] = Fluid3D([10773,11055,11046,11755],0); -ELEMENTS[7794] = Fluid3D([11055,11046,11755,12222],0); -ELEMENTS[7795] = Fluid3D([11055,10167,11046,9914],0); -ELEMENTS[7796] = Fluid3D([10820,10167,11055,10257],0); -ELEMENTS[7797] = Fluid3D([10103,10167,10820,9852],0); -ELEMENTS[7798] = Fluid3D([10773,10820,11055,11755],0); -ELEMENTS[7799] = Fluid3D([10167,10820,9852,10257],0); -ELEMENTS[7800] = Fluid3D([10167,11055,10257,9914],0); -ELEMENTS[7801] = Fluid3D([10167,10138,10773,11046],0); -ELEMENTS[7802] = Fluid3D([10773,10103,10820,11048],0); -ELEMENTS[7803] = Fluid3D([10773,10103,11048,10305],0); -ELEMENTS[7804] = Fluid3D([10103,11048,10305,10217],0); -ELEMENTS[7805] = Fluid3D([10305,10103,10217,9504],0); -ELEMENTS[7806] = Fluid3D([10305,10103,9504,9838],0); -ELEMENTS[7807] = Fluid3D([10305,10103,9838,10773],0); -ELEMENTS[7808] = Fluid3D([9504,10305,9838,9762],0); -ELEMENTS[7809] = Fluid3D([9838,10305,10773,10406],0); -ELEMENTS[7810] = Fluid3D([9838,10305,10406,9762],0); -ELEMENTS[7811] = Fluid3D([10103,11048,10217,10528],0); -ELEMENTS[7812] = Fluid3D([10103,10167,9852,9083],0); -ELEMENTS[7813] = Fluid3D([10103,11048,10528,10820],0); -ELEMENTS[7814] = Fluid3D([10103,10217,9504,9532],0); -ELEMENTS[7815] = Fluid3D([9852,10167,10257,9321],0); -ELEMENTS[7816] = Fluid3D([10257,9852,9321,9699],0); -ELEMENTS[7817] = Fluid3D([9852,9321,9699,9358],0); -ELEMENTS[7818] = Fluid3D([9852,10167,9321,9083],0); -ELEMENTS[7819] = Fluid3D([9321,9852,9083,8643],0); -ELEMENTS[7820] = Fluid3D([9321,10257,9699,9741],0); -ELEMENTS[7821] = Fluid3D([10167,10257,9321,9914],0); -ELEMENTS[7822] = Fluid3D([10103,10217,9532,10528],0); -ELEMENTS[7823] = Fluid3D([10257,9852,9699,10531],0); -ELEMENTS[7824] = Fluid3D([10217,10305,9504,10087],0); -ELEMENTS[7825] = Fluid3D([9504,10103,9532,9083],0); -ELEMENTS[7826] = Fluid3D([9852,9699,10531,9358],0); -ELEMENTS[7827] = Fluid3D([9532,10103,10528,9852],0); -ELEMENTS[7828] = Fluid3D([10820,9852,10257,10531],0); -ELEMENTS[7829] = Fluid3D([10406,9838,9762,9430],0); -ELEMENTS[7830] = Fluid3D([9838,9762,9430,9504],0); -ELEMENTS[7831] = Fluid3D([10406,9838,9430,9862],0); -ELEMENTS[7832] = Fluid3D([9838,9430,9862,9373],0); -ELEMENTS[7833] = Fluid3D([9838,9430,9373,9156],0); -ELEMENTS[7834] = Fluid3D([9838,9430,9156,9504],0); -ELEMENTS[7835] = Fluid3D([9156,9838,9504,10103],0); -ELEMENTS[7836] = Fluid3D([9762,10406,9430,9905],0); -ELEMENTS[7837] = Fluid3D([9430,9762,9905,9012],0); -ELEMENTS[7838] = Fluid3D([9430,9762,9012,8889],0); -ELEMENTS[7839] = Fluid3D([9430,9762,8889,9504],0); -ELEMENTS[7840] = Fluid3D([9012,9430,8889,8382],0); -ELEMENTS[7841] = Fluid3D([9373,9838,9156,9083],0); -ELEMENTS[7842] = Fluid3D([9762,9012,8889,9072],0); -ELEMENTS[7843] = Fluid3D([8889,9762,9072,9487],0); -ELEMENTS[7844] = Fluid3D([8889,9762,9487,9504],0); -ELEMENTS[7845] = Fluid3D([9430,9156,9504,8889],0); -ELEMENTS[7846] = Fluid3D([9156,9504,8889,8009],0); -ELEMENTS[7847] = Fluid3D([9430,9156,8889,8382],0); -ELEMENTS[7848] = Fluid3D([9838,10167,10103,9083],0); -ELEMENTS[7849] = Fluid3D([9905,9430,9012,9111],0); -ELEMENTS[7850] = Fluid3D([11048,10305,10217,11012],0); -ELEMENTS[7851] = Fluid3D([10217,9532,10528,10071],0); -ELEMENTS[7852] = Fluid3D([11055,10820,10257,11377],0); -ELEMENTS[7853] = Fluid3D([10820,10257,11377,10531],0); -ELEMENTS[7854] = Fluid3D([9504,9156,10103,9083],0); -ELEMENTS[7855] = Fluid3D([9504,9156,9083,8500],0); -ELEMENTS[7856] = Fluid3D([9504,9156,8500,8009],0); -ELEMENTS[7857] = Fluid3D([9156,9083,8500,8134],0); -ELEMENTS[7858] = Fluid3D([10217,9532,10071,9476],0); -ELEMENTS[7859] = Fluid3D([10217,9532,9476,9504],0); -ELEMENTS[7860] = Fluid3D([9532,10071,9476,8685],0); -ELEMENTS[7861] = Fluid3D([9532,10071,8685,9781],0); -ELEMENTS[7862] = Fluid3D([9532,10071,9781,10528],0); -ELEMENTS[7863] = Fluid3D([10071,10217,9476,10268],0); -ELEMENTS[7864] = Fluid3D([9762,9072,9487,10016],0); -ELEMENTS[7865] = Fluid3D([9762,9072,10016,9753],0); -ELEMENTS[7866] = Fluid3D([9762,9072,9753,9012],0); -ELEMENTS[7867] = Fluid3D([9487,9762,10016,10724],0); -ELEMENTS[7868] = Fluid3D([9072,10016,9753,9372],0); -ELEMENTS[7869] = Fluid3D([9072,10016,9372,9104],0); -ELEMENTS[7870] = Fluid3D([10820,9852,10531,10528],0); -ELEMENTS[7871] = Fluid3D([11048,10217,10528,11119],0); -ELEMENTS[7872] = Fluid3D([10528,11048,11119,11560],0); -ELEMENTS[7873] = Fluid3D([10217,10528,11119,10071],0); -ELEMENTS[7874] = Fluid3D([11119,10528,11560,11105],0); -ELEMENTS[7875] = Fluid3D([11119,10528,11105,10071],0); -ELEMENTS[7876] = Fluid3D([10528,11048,11560,10820],0); -ELEMENTS[7877] = Fluid3D([10528,11560,11105,11020],0); -ELEMENTS[7878] = Fluid3D([10528,11560,11020,10820],0); -ELEMENTS[7879] = Fluid3D([9699,10257,10531,10556],0); -ELEMENTS[7880] = Fluid3D([10531,9699,10556,10119],0); -ELEMENTS[7881] = Fluid3D([9699,10257,10556,9895],0); -ELEMENTS[7882] = Fluid3D([9699,10257,9895,9741],0); -ELEMENTS[7883] = Fluid3D([9699,10556,10119,10093],0); -ELEMENTS[7884] = Fluid3D([10531,9699,10119,9358],0); -ELEMENTS[7885] = Fluid3D([9699,10119,9358,10093],0); -ELEMENTS[7886] = Fluid3D([10257,10531,10556,11377],0); -ELEMENTS[7887] = Fluid3D([10556,10531,10119,11159],0); -ELEMENTS[7888] = Fluid3D([10556,10531,11159,11377],0); -ELEMENTS[7889] = Fluid3D([10531,10119,11159,10673],0); -ELEMENTS[7890] = Fluid3D([10820,10103,9852,10528],0); -ELEMENTS[7891] = Fluid3D([10016,9762,9753,10492],0); -ELEMENTS[7892] = Fluid3D([9762,9753,10492,9905],0); -ELEMENTS[7893] = Fluid3D([9753,10016,10492,10502],0); -ELEMENTS[7894] = Fluid3D([10492,9753,10502,10456],0); -ELEMENTS[7895] = Fluid3D([9753,10492,9905,10456],0); -ELEMENTS[7896] = Fluid3D([9753,10016,10502,9372],0); -ELEMENTS[7897] = Fluid3D([10556,9699,9895,10093],0); -ELEMENTS[7898] = Fluid3D([9072,8889,9487,8531],0); -ELEMENTS[7899] = Fluid3D([8889,9487,8531,9504],0); -ELEMENTS[7900] = Fluid3D([9072,8889,8531,7892],0); -ELEMENTS[7901] = Fluid3D([10257,11055,11377,11059],0); -ELEMENTS[7902] = Fluid3D([10257,11055,11059,9914],0); -ELEMENTS[7903] = Fluid3D([11377,10257,11059,10556],0); -ELEMENTS[7904] = Fluid3D([9476,9532,8685,8500],0); -ELEMENTS[7905] = Fluid3D([10217,9476,10268,10087],0); -ELEMENTS[7906] = Fluid3D([10257,10556,9895,10449],0); -ELEMENTS[7907] = Fluid3D([9895,10257,10449,9741],0); -ELEMENTS[7908] = Fluid3D([10449,9895,9741,10014],0); -ELEMENTS[7909] = Fluid3D([10556,9895,10449,10014],0); -ELEMENTS[7910] = Fluid3D([11055,10820,11377,11782],0); -ELEMENTS[7911] = Fluid3D([10820,11377,11782,11551],0); -ELEMENTS[7912] = Fluid3D([10820,11377,11551,10531],0); -ELEMENTS[7913] = Fluid3D([10138,9373,9838,9862],0); -ELEMENTS[7914] = Fluid3D([9838,10138,9862,10406],0); -ELEMENTS[7915] = Fluid3D([10138,9373,9862,9512],0); -ELEMENTS[7916] = Fluid3D([9862,10138,9512,10686],0); -ELEMENTS[7917] = Fluid3D([9862,10138,10686,10406],0); -ELEMENTS[7918] = Fluid3D([11055,10820,11782,11755],0); -ELEMENTS[7919] = Fluid3D([11782,11055,11755,12222],0); -ELEMENTS[7920] = Fluid3D([10071,8685,9781,9790],0); -ELEMENTS[7921] = Fluid3D([9781,10071,9790,11105],0); -ELEMENTS[7922] = Fluid3D([10071,8685,9790,9552],0); -ELEMENTS[7923] = Fluid3D([10071,8685,9552,9476],0); -ELEMENTS[7924] = Fluid3D([9790,10071,9552,10527],0); -ELEMENTS[7925] = Fluid3D([9790,10071,10527,11105],0); -ELEMENTS[7926] = Fluid3D([8685,9781,9790,9068],0); -ELEMENTS[7927] = Fluid3D([9781,9790,9068,9956],0); -ELEMENTS[7928] = Fluid3D([9781,9790,9956,11105],0); -ELEMENTS[7929] = Fluid3D([9552,9790,10527,9821],0); -ELEMENTS[7930] = Fluid3D([9790,10527,9821,10552],0); -ELEMENTS[7931] = Fluid3D([9790,10527,10552,11105],0); -ELEMENTS[7932] = Fluid3D([8685,9781,9068,8552],0); -ELEMENTS[7933] = Fluid3D([9552,9790,9821,8959],0); -ELEMENTS[7934] = Fluid3D([9552,9790,8959,8685],0); -ELEMENTS[7935] = Fluid3D([9790,9821,8959,9488],0); -ELEMENTS[7936] = Fluid3D([9790,9821,9488,10552],0); -ELEMENTS[7937] = Fluid3D([8959,9790,9488,9068],0); -ELEMENTS[7938] = Fluid3D([9821,9552,8959,9098],0); -ELEMENTS[7939] = Fluid3D([9552,8959,9098,8683],0); -ELEMENTS[7940] = Fluid3D([9552,8959,8683,8685],0); -ELEMENTS[7941] = Fluid3D([8959,9821,9098,9035],0); -ELEMENTS[7942] = Fluid3D([8959,9821,9035,9488],0); -ELEMENTS[7943] = Fluid3D([9821,9098,9035,9704],0); -ELEMENTS[7944] = Fluid3D([9821,9552,9098,10043],0); -ELEMENTS[7945] = Fluid3D([9035,9821,9704,9945],0); -ELEMENTS[7946] = Fluid3D([9035,9821,9945,9488],0); -ELEMENTS[7947] = Fluid3D([9821,9098,9704,10043],0); -ELEMENTS[7948] = Fluid3D([9821,9552,10043,10527],0); -ELEMENTS[7949] = Fluid3D([9098,9035,9704,8754],0); -ELEMENTS[7950] = Fluid3D([9035,9704,8754,9217],0); -ELEMENTS[7951] = Fluid3D([9098,9035,8754,8246],0); -ELEMENTS[7952] = Fluid3D([9098,9035,8246,8959],0); -ELEMENTS[7953] = Fluid3D([9704,8754,9217,9408],0); -ELEMENTS[7954] = Fluid3D([9704,9098,8754,9330],0); -ELEMENTS[7955] = Fluid3D([9704,8754,9408,9330],0); -ELEMENTS[7956] = Fluid3D([9704,9098,9330,10043],0); -ELEMENTS[7957] = Fluid3D([8754,9217,9408,8568],0); -ELEMENTS[7958] = Fluid3D([9217,9408,8568,9510],0); -ELEMENTS[7959] = Fluid3D([9217,9408,9510,10142],0); -ELEMENTS[7960] = Fluid3D([9217,9408,10142,9704],0); -ELEMENTS[7961] = Fluid3D([9408,8754,8568,8599],0); -ELEMENTS[7962] = Fluid3D([9408,8754,8599,9330],0); -ELEMENTS[7963] = Fluid3D([8568,9408,8599,9107],0); -ELEMENTS[7964] = Fluid3D([8568,9408,9107,9510],0); -ELEMENTS[7965] = Fluid3D([9408,8599,9107,9433],0); -ELEMENTS[7966] = Fluid3D([8754,9217,8568,8299],0); -ELEMENTS[7967] = Fluid3D([9408,8599,9433,9330],0); -ELEMENTS[7968] = Fluid3D([8754,9217,8299,9035],0); -ELEMENTS[7969] = Fluid3D([8599,9107,9433,8606],0); -ELEMENTS[7970] = Fluid3D([9433,8599,8606,8917],0); -ELEMENTS[7971] = Fluid3D([8599,9107,8606,8054],0); -ELEMENTS[7972] = Fluid3D([8599,9107,8054,8568],0); -ELEMENTS[7973] = Fluid3D([9107,9433,8606,9421],0); -ELEMENTS[7974] = Fluid3D([9433,8606,9421,9338],0); -ELEMENTS[7975] = Fluid3D([9433,8606,9338,8917],0); -ELEMENTS[7976] = Fluid3D([9107,9433,9421,9982],0); -ELEMENTS[7977] = Fluid3D([9107,9433,9982,9408],0); -ELEMENTS[7978] = Fluid3D([9433,9421,9982,10264],0); -ELEMENTS[7979] = Fluid3D([9433,9421,10264,9338],0); -ELEMENTS[7980] = Fluid3D([9982,9433,10264,10378],0); -ELEMENTS[7981] = Fluid3D([9107,8606,8054,8494],0); -ELEMENTS[7982] = Fluid3D([9982,9433,10378,9408],0); -ELEMENTS[7983] = Fluid3D([9107,8606,8494,9421],0); -ELEMENTS[7984] = Fluid3D([10264,9982,10378,10985],0); -ELEMENTS[7985] = Fluid3D([9982,10378,10985,10630],0); -ELEMENTS[7986] = Fluid3D([9982,10378,10630,9408],0); -ELEMENTS[7987] = Fluid3D([10264,9982,10985,10463],0); -ELEMENTS[7988] = Fluid3D([10264,9982,10463,9421],0); -ELEMENTS[7989] = Fluid3D([9982,10985,10463,10698],0); -ELEMENTS[7990] = Fluid3D([10378,10985,10630,11364],0); -ELEMENTS[7991] = Fluid3D([9982,10985,10698,10630],0); -ELEMENTS[7992] = Fluid3D([10378,10985,11364,11182],0); -ELEMENTS[7993] = Fluid3D([10378,10985,11182,10264],0); -ELEMENTS[7994] = Fluid3D([10463,9982,10698,9779],0); -ELEMENTS[7995] = Fluid3D([10463,9982,9779,9421],0); -ELEMENTS[7996] = Fluid3D([11364,10378,11182,10959],0); -ELEMENTS[7997] = Fluid3D([11364,10378,10959,10612],0); -ELEMENTS[7998] = Fluid3D([11364,10378,10612,10630],0); -ELEMENTS[7999] = Fluid3D([10378,11182,10959,10338],0); -ELEMENTS[8000] = Fluid3D([10378,11182,10338,10264],0); -ELEMENTS[8001] = Fluid3D([10698,10463,9779,10635],0); -ELEMENTS[8002] = Fluid3D([10463,9779,10635,9828],0); -ELEMENTS[8003] = Fluid3D([10463,9779,9828,9421],0); -ELEMENTS[8004] = Fluid3D([10698,10463,10635,11419],0); -ELEMENTS[8005] = Fluid3D([11182,10959,10338,11292],0); -ELEMENTS[8006] = Fluid3D([11182,10959,11292,11900],0); -ELEMENTS[8007] = Fluid3D([10698,10463,11419,10985],0); -ELEMENTS[8008] = Fluid3D([10463,10635,11419,11006],0); -ELEMENTS[8009] = Fluid3D([10463,10635,11006,9828],0); -ELEMENTS[8010] = Fluid3D([11182,10959,11900,11364],0); -ELEMENTS[8011] = Fluid3D([10635,11419,11006,11582],0); -ELEMENTS[8012] = Fluid3D([11006,10635,11582,10709],0); -ELEMENTS[8013] = Fluid3D([11006,10635,10709,9828],0); -ELEMENTS[8014] = Fluid3D([10635,11419,11582,11445],0); -ELEMENTS[8015] = Fluid3D([11419,11582,11445,12278],0); -ELEMENTS[8016] = Fluid3D([10635,11419,11445,10698],0); -ELEMENTS[8017] = Fluid3D([11419,11582,12278,12090],0); -ELEMENTS[8018] = Fluid3D([12278,11419,12090,12295],0); -ELEMENTS[8019] = Fluid3D([12278,11419,12295,11913],0); -ELEMENTS[8020] = Fluid3D([12278,11419,11913,11445],0); -ELEMENTS[8021] = Fluid3D([11419,11582,12090,11006],0); -ELEMENTS[8022] = Fluid3D([9035,9704,9217,9945],0); -ELEMENTS[8023] = Fluid3D([9012,8889,9072,8330],0); -ELEMENTS[8024] = Fluid3D([9072,9012,8330,9753],0); -ELEMENTS[8025] = Fluid3D([11048,10217,11119,11012],0); -ELEMENTS[8026] = Fluid3D([9072,9487,10016,9104],0); -ELEMENTS[8027] = Fluid3D([9852,10103,9083,9532],0); -ELEMENTS[8028] = Fluid3D([10071,9552,10527,10268],0); -ELEMENTS[8029] = Fluid3D([8685,9532,9781,8552],0); -ELEMENTS[8030] = Fluid3D([11560,11119,11105,11992],0); -ELEMENTS[8031] = Fluid3D([11119,11105,11992,11278],0); -ELEMENTS[8032] = Fluid3D([11105,11560,11992,11982],0); -ELEMENTS[8033] = Fluid3D([11992,11105,11982,11834],0); -ELEMENTS[8034] = Fluid3D([11992,11119,11278,11439],0); -ELEMENTS[8035] = Fluid3D([11119,11278,11439,10268],0); -ELEMENTS[8036] = Fluid3D([11992,11119,11439,11986],0); -ELEMENTS[8037] = Fluid3D([11560,11119,11992,11986],0); -ELEMENTS[8038] = Fluid3D([11439,11119,10268,11012],0); -ELEMENTS[8039] = Fluid3D([11439,11119,11012,11986],0); -ELEMENTS[8040] = Fluid3D([11105,11560,11982,11020],0); -ELEMENTS[8041] = Fluid3D([11992,11105,11834,11278],0); -ELEMENTS[8042] = Fluid3D([11982,11992,11834,12718],0); -ELEMENTS[8043] = Fluid3D([11992,11834,12718,12405],0); -ELEMENTS[8044] = Fluid3D([11834,12718,12405,12671],0); -ELEMENTS[8045] = Fluid3D([11982,11992,12718,12622],0); -ELEMENTS[8046] = Fluid3D([11992,12718,12622,13066],0); -ELEMENTS[8047] = Fluid3D([11992,12718,13066,12405],0); -ELEMENTS[8048] = Fluid3D([11834,12718,12671,12432],0); -ELEMENTS[8049] = Fluid3D([11834,12718,12432,11982],0); -ELEMENTS[8050] = Fluid3D([11982,11992,12622,11560],0); -ELEMENTS[8051] = Fluid3D([12671,11834,12432,11899],0); -ELEMENTS[8052] = Fluid3D([12671,11834,11899,11847],0); -ELEMENTS[8053] = Fluid3D([12671,11834,11847,12405],0); -ELEMENTS[8054] = Fluid3D([11834,12432,11899,11448],0); -ELEMENTS[8055] = Fluid3D([11834,12432,11448,11982],0); -ELEMENTS[8056] = Fluid3D([11899,11834,11448,10552],0); -ELEMENTS[8057] = Fluid3D([11899,12671,11847,12455],0); -ELEMENTS[8058] = Fluid3D([12671,11847,12455,12690],0); -ELEMENTS[8059] = Fluid3D([12671,11847,12690,12405],0); -ELEMENTS[8060] = Fluid3D([11899,12671,12455,12831],0); -ELEMENTS[8061] = Fluid3D([11899,12671,12831,12432],0); -ELEMENTS[8062] = Fluid3D([12671,12455,12831,13256],0); -ELEMENTS[8063] = Fluid3D([12671,12455,13256,12690],0); -ELEMENTS[8064] = Fluid3D([12831,12671,13256,13440],0); -ELEMENTS[8065] = Fluid3D([12831,12671,13440,12432],0); -ELEMENTS[8066] = Fluid3D([11847,11899,12455,11473],0); -ELEMENTS[8067] = Fluid3D([12671,13256,13440,13471],0); -ELEMENTS[8068] = Fluid3D([12671,13256,13471,12690],0); -ELEMENTS[8069] = Fluid3D([11899,12455,11473,12054],0); -ELEMENTS[8070] = Fluid3D([11899,12455,12054,12831],0); -ELEMENTS[8071] = Fluid3D([12455,11473,12054,12088],0); -ELEMENTS[8072] = Fluid3D([12455,11473,12088,11978],0); -ELEMENTS[8073] = Fluid3D([12455,11473,11978,11847],0); -ELEMENTS[8074] = Fluid3D([11847,11899,11473,10552],0); -ELEMENTS[8075] = Fluid3D([11473,12054,12088,11271],0); -ELEMENTS[8076] = Fluid3D([12088,11473,11271,11164],0); -ELEMENTS[8077] = Fluid3D([12088,11473,11164,11978],0); -ELEMENTS[8078] = Fluid3D([11473,12054,11271,11095],0); -ELEMENTS[8079] = Fluid3D([11473,12054,11095,11899],0); -ELEMENTS[8080] = Fluid3D([11271,11473,11095,10474],0); -ELEMENTS[8081] = Fluid3D([11271,11473,10474,11164],0); -ELEMENTS[8082] = Fluid3D([12054,12088,11271,12147],0); -ELEMENTS[8083] = Fluid3D([12054,12088,12147,12884],0); -ELEMENTS[8084] = Fluid3D([12054,12088,12884,12455],0); -ELEMENTS[8085] = Fluid3D([11095,11271,10474,10432],0); -ELEMENTS[8086] = Fluid3D([11271,12054,12147,11570],0); -ELEMENTS[8087] = Fluid3D([11095,11271,10432,11570],0); -ELEMENTS[8088] = Fluid3D([11271,12054,11570,11095],0); -ELEMENTS[8089] = Fluid3D([10474,11095,10432,9935],0); -ELEMENTS[8090] = Fluid3D([10474,11095,9935,10552],0); -ELEMENTS[8091] = Fluid3D([11095,10432,9935,10372],0); -ELEMENTS[8092] = Fluid3D([11992,11834,12405,11278],0); -ELEMENTS[8093] = Fluid3D([12718,12405,12671,13471],0); -ELEMENTS[8094] = Fluid3D([12455,12831,13256,12884],0); -ELEMENTS[8095] = Fluid3D([11119,11105,11278,10071],0); -ELEMENTS[8096] = Fluid3D([11105,11982,11834,11448],0); -ELEMENTS[8097] = Fluid3D([12718,12671,12432,13440],0); -ELEMENTS[8098] = Fluid3D([12147,11271,11570,11282],0); -ELEMENTS[8099] = Fluid3D([12147,11271,11282,11576],0); -ELEMENTS[8100] = Fluid3D([11282,12147,11576,12057],0); -ELEMENTS[8101] = Fluid3D([11570,12147,11282,12066],0); -ELEMENTS[8102] = Fluid3D([11282,12147,12057,12066],0); -ELEMENTS[8103] = Fluid3D([11570,12147,12066,12549],0); -ELEMENTS[8104] = Fluid3D([11570,12147,12549,12054],0); -ELEMENTS[8105] = Fluid3D([12066,11570,12549,11823],0); -ELEMENTS[8106] = Fluid3D([11282,11570,12066,11118],0); -ELEMENTS[8107] = Fluid3D([12066,11282,11118,11447],0); -ELEMENTS[8108] = Fluid3D([12066,11282,11447,12057],0); -ELEMENTS[8109] = Fluid3D([11570,12066,11118,11823],0); -ELEMENTS[8110] = Fluid3D([11282,11570,11118,10432],0); -ELEMENTS[8111] = Fluid3D([12147,11271,11576,12088],0); -ELEMENTS[8112] = Fluid3D([11271,11570,11282,10432],0); -ELEMENTS[8113] = Fluid3D([11576,11282,12057,11130],0); -ELEMENTS[8114] = Fluid3D([11282,12057,11130,11447],0); -ELEMENTS[8115] = Fluid3D([11576,11282,11130,10479],0); -ELEMENTS[8116] = Fluid3D([11130,11576,10479,10932],0); -ELEMENTS[8117] = Fluid3D([11130,11576,10932,11843],0); -ELEMENTS[8118] = Fluid3D([11130,11576,11843,12057],0); -ELEMENTS[8119] = Fluid3D([11576,10932,11843,11774],0); -ELEMENTS[8120] = Fluid3D([11843,11576,11774,12507],0); -ELEMENTS[8121] = Fluid3D([11843,11576,12507,12057],0); -ELEMENTS[8122] = Fluid3D([11576,10932,11774,11164],0); -ELEMENTS[8123] = Fluid3D([11576,11282,10479,11271],0); -ELEMENTS[8124] = Fluid3D([11282,11130,10479,10407],0); -ELEMENTS[8125] = Fluid3D([11282,11130,10407,11447],0); -ELEMENTS[8126] = Fluid3D([11130,10479,10407,10118],0); -ELEMENTS[8127] = Fluid3D([11130,10479,10118,10932],0); -ELEMENTS[8128] = Fluid3D([10407,11130,10118,10559],0); -ELEMENTS[8129] = Fluid3D([10407,11130,10559,11447],0); -ELEMENTS[8130] = Fluid3D([11130,10118,10559,10835],0); -ELEMENTS[8131] = Fluid3D([11130,10118,10835,10932],0); -ELEMENTS[8132] = Fluid3D([10479,11282,10407,10432],0); -ELEMENTS[8133] = Fluid3D([10118,10559,10835,9877],0); -ELEMENTS[8134] = Fluid3D([10835,10118,9877,9855],0); -ELEMENTS[8135] = Fluid3D([10835,10118,9855,10932],0); -ELEMENTS[8136] = Fluid3D([10559,10835,9877,10720],0); -ELEMENTS[8137] = Fluid3D([10559,10835,10720,11423],0); -ELEMENTS[8138] = Fluid3D([10559,10835,11423,11130],0); -ELEMENTS[8139] = Fluid3D([10835,9877,10720,10391],0); -ELEMENTS[8140] = Fluid3D([10835,9877,10391,9855],0); -ELEMENTS[8141] = Fluid3D([10720,10835,10391,11403],0); -ELEMENTS[8142] = Fluid3D([10720,10835,11403,11423],0); -ELEMENTS[8143] = Fluid3D([10391,10720,11403,10876],0); -ELEMENTS[8144] = Fluid3D([11403,10391,10876,11072],0); -ELEMENTS[8145] = Fluid3D([10391,10720,10876,9902],0); -ELEMENTS[8146] = Fluid3D([11403,10391,11072,11058],0); -ELEMENTS[8147] = Fluid3D([11403,10391,11058,10835],0); -ELEMENTS[8148] = Fluid3D([10391,10720,9902,9877],0); -ELEMENTS[8149] = Fluid3D([10118,10559,9877,9568],0); -ELEMENTS[8150] = Fluid3D([10118,10559,9568,10407],0); -ELEMENTS[8151] = Fluid3D([9877,10118,9568,9088],0); -ELEMENTS[8152] = Fluid3D([10118,9568,9088,9261],0); -ELEMENTS[8153] = Fluid3D([10118,9568,9261,10407],0); -ELEMENTS[8154] = Fluid3D([9877,10118,9088,9855],0); -ELEMENTS[8155] = Fluid3D([10559,9877,9568,9761],0); -ELEMENTS[8156] = Fluid3D([9877,9568,9761,9014],0); -ELEMENTS[8157] = Fluid3D([9877,9568,9014,9088],0); -ELEMENTS[8158] = Fluid3D([9568,10559,9761,10117],0); -ELEMENTS[8159] = Fluid3D([9568,10559,10117,10407],0); -ELEMENTS[8160] = Fluid3D([10559,9761,10117,10831],0); -ELEMENTS[8161] = Fluid3D([9761,10117,10831,10010],0); -ELEMENTS[8162] = Fluid3D([10559,9761,10831,10720],0); -ELEMENTS[8163] = Fluid3D([9761,10117,10010,9135],0); -ELEMENTS[8164] = Fluid3D([9761,10117,9135,9568],0); -ELEMENTS[8165] = Fluid3D([10117,10010,9135,9857],0); -ELEMENTS[8166] = Fluid3D([9135,10117,9857,9417],0); -ELEMENTS[8167] = Fluid3D([10117,9857,9417,10109],0); -ELEMENTS[8168] = Fluid3D([9135,10117,9417,9568],0); -ELEMENTS[8169] = Fluid3D([10117,9417,9568,10407],0); -ELEMENTS[8170] = Fluid3D([9417,9135,9568,8645],0); -ELEMENTS[8171] = Fluid3D([9568,9417,8645,9261],0); -ELEMENTS[8172] = Fluid3D([9568,9417,9261,10407],0); -ELEMENTS[8173] = Fluid3D([10559,9877,9761,10720],0); -ELEMENTS[8174] = Fluid3D([11576,10479,10932,11164],0); -ELEMENTS[8175] = Fluid3D([10932,11843,11774,11480],0); -ELEMENTS[8176] = Fluid3D([11774,10932,11480,10928],0); -ELEMENTS[8177] = Fluid3D([11843,11774,11480,12607],0); -ELEMENTS[8178] = Fluid3D([11843,11774,12607,12507],0); -ELEMENTS[8179] = Fluid3D([11480,11774,10928,11637],0); -ELEMENTS[8180] = Fluid3D([11774,10928,11637,11790],0); -ELEMENTS[8181] = Fluid3D([11774,10928,11790,11164],0); -ELEMENTS[8182] = Fluid3D([11480,11774,11637,12607],0); -ELEMENTS[8183] = Fluid3D([10932,11843,11480,10835],0); -ELEMENTS[8184] = Fluid3D([10479,10407,10118,9261],0); -ELEMENTS[8185] = Fluid3D([11774,10932,10928,11164],0); -ELEMENTS[8186] = Fluid3D([10932,11480,10928,10431],0); -ELEMENTS[8187] = Fluid3D([10932,11480,10431,10835],0); -ELEMENTS[8188] = Fluid3D([11480,10928,10431,11028],0); -ELEMENTS[8189] = Fluid3D([10431,11480,11028,11058],0); -ELEMENTS[8190] = Fluid3D([11480,10928,11028,11637],0); -ELEMENTS[8191] = Fluid3D([10928,10932,10431,9962],0); -ELEMENTS[8192] = Fluid3D([10932,10431,9962,9855],0); -ELEMENTS[8193] = Fluid3D([10431,9962,9855,9560],0); -ELEMENTS[8194] = Fluid3D([9855,10431,9560,10050],0); -ELEMENTS[8195] = Fluid3D([9855,10431,10050,11058],0); -ELEMENTS[8196] = Fluid3D([10431,9560,10050,11028],0); -ELEMENTS[8197] = Fluid3D([9560,9855,10050,9178],0); -ELEMENTS[8198] = Fluid3D([9855,10050,9178,10391],0); -ELEMENTS[8199] = Fluid3D([10932,10431,9855,10835],0); -ELEMENTS[8200] = Fluid3D([10431,9855,10835,11058],0); -ELEMENTS[8201] = Fluid3D([10431,9962,9560,10928],0); -ELEMENTS[8202] = Fluid3D([10928,10932,9962,11164],0); -ELEMENTS[8203] = Fluid3D([10050,9560,9178,9214],0); -ELEMENTS[8204] = Fluid3D([9178,10050,9214,9406],0); -ELEMENTS[8205] = Fluid3D([9178,10050,9406,10391],0); -ELEMENTS[8206] = Fluid3D([9214,9178,9406,8501],0); -ELEMENTS[8207] = Fluid3D([9178,9406,8501,8849],0); -ELEMENTS[8208] = Fluid3D([9178,9406,8849,10391],0); -ELEMENTS[8209] = Fluid3D([10050,9214,9406,9958],0); -ELEMENTS[8210] = Fluid3D([9406,10050,9958,10426],0); -ELEMENTS[8211] = Fluid3D([9406,10050,10426,10391],0); -ELEMENTS[8212] = Fluid3D([10050,9958,10426,10912],0); -ELEMENTS[8213] = Fluid3D([9406,9214,8501,8935],0); -ELEMENTS[8214] = Fluid3D([9406,9214,8935,9958],0); -ELEMENTS[8215] = Fluid3D([9560,9178,9214,8588],0); -ELEMENTS[8216] = Fluid3D([9178,9214,8588,8501],0); -ELEMENTS[8217] = Fluid3D([9560,9178,8588,9143],0); -ELEMENTS[8218] = Fluid3D([8588,9560,9143,8919],0); -ELEMENTS[8219] = Fluid3D([8588,9560,8919,9206],0); -ELEMENTS[8220] = Fluid3D([8588,9560,9206,9214],0); -ELEMENTS[8221] = Fluid3D([9560,9178,9143,9855],0); -ELEMENTS[8222] = Fluid3D([10050,9560,9214,10130],0); -ELEMENTS[8223] = Fluid3D([9560,9214,10130,9206],0); -ELEMENTS[8224] = Fluid3D([10050,9560,10130,11028],0); -ELEMENTS[8225] = Fluid3D([10928,10431,11028,9560],0); -ELEMENTS[8226] = Fluid3D([9214,10050,10130,9958],0); -ELEMENTS[8227] = Fluid3D([9178,8588,9143,8309],0); -ELEMENTS[8228] = Fluid3D([8588,9143,8309,8102],0); -ELEMENTS[8229] = Fluid3D([9143,8309,8102,8351],0); -ELEMENTS[8230] = Fluid3D([8102,9143,8351,8745],0); -ELEMENTS[8231] = Fluid3D([8102,9143,8745,8919],0); -ELEMENTS[8232] = Fluid3D([9143,8309,8351,9088],0); -ELEMENTS[8233] = Fluid3D([8351,9143,9088,8745],0); -ELEMENTS[8234] = Fluid3D([9143,8309,9088,9178],0); -ELEMENTS[8235] = Fluid3D([9088,9143,9178,9855],0); -ELEMENTS[8236] = Fluid3D([9088,9143,9855,10118],0); -ELEMENTS[8237] = Fluid3D([9143,9088,8745,9261],0); -ELEMENTS[8238] = Fluid3D([9178,8588,8309,8501],0); -ELEMENTS[8239] = Fluid3D([8588,9143,8102,8919],0); -ELEMENTS[8240] = Fluid3D([8309,8588,8102,7703],0); -ELEMENTS[8241] = Fluid3D([8588,8102,7703,7961],0); -ELEMENTS[8242] = Fluid3D([8102,7703,7961,7272],0); -ELEMENTS[8243] = Fluid3D([8102,7703,7272,7432],0); -ELEMENTS[8244] = Fluid3D([7703,7272,7432,6856],0); -ELEMENTS[8245] = Fluid3D([7703,7272,6856,7193],0); -ELEMENTS[8246] = Fluid3D([7703,7272,7193,7961],0); -ELEMENTS[8247] = Fluid3D([8102,7703,7432,8309],0); -ELEMENTS[8248] = Fluid3D([8309,8588,7703,8501],0); -ELEMENTS[8249] = Fluid3D([8588,8102,7961,8919],0); -ELEMENTS[8250] = Fluid3D([9406,8501,8849,8667],0); -ELEMENTS[8251] = Fluid3D([8849,9406,8667,9607],0); -ELEMENTS[8252] = Fluid3D([9406,8501,8667,8935],0); -ELEMENTS[8253] = Fluid3D([9406,8667,9607,9533],0); -ELEMENTS[8254] = Fluid3D([9406,8667,9533,8935],0); -ELEMENTS[8255] = Fluid3D([9607,9406,9533,10426],0); -ELEMENTS[8256] = Fluid3D([8667,9607,9533,9033],0); -ELEMENTS[8257] = Fluid3D([9533,8667,9033,8702],0); -ELEMENTS[8258] = Fluid3D([9533,8667,8702,8935],0); -ELEMENTS[8259] = Fluid3D([9607,9533,9033,9992],0); -ELEMENTS[8260] = Fluid3D([9607,9533,9992,10426],0); -ELEMENTS[8261] = Fluid3D([9533,9033,9992,9609],0); -ELEMENTS[8262] = Fluid3D([9533,9033,9609,8702],0); -ELEMENTS[8263] = Fluid3D([8667,9607,9033,8590],0); -ELEMENTS[8264] = Fluid3D([9033,9992,9609,9553],0); -ELEMENTS[8265] = Fluid3D([9033,9992,9553,9381],0); -ELEMENTS[8266] = Fluid3D([9607,9033,8590,9381],0); -ELEMENTS[8267] = Fluid3D([9033,9992,9381,9607],0); -ELEMENTS[8268] = Fluid3D([8667,9607,8590,8849],0); -ELEMENTS[8269] = Fluid3D([8849,9406,9607,10391],0); -ELEMENTS[8270] = Fluid3D([8501,8849,8667,8065],0); -ELEMENTS[8271] = Fluid3D([8849,8667,8065,8590],0); -ELEMENTS[8272] = Fluid3D([8501,8849,8065,8309],0); -ELEMENTS[8273] = Fluid3D([8667,8501,8065,7926],0); -ELEMENTS[8274] = Fluid3D([8667,8501,7926,8935],0); -ELEMENTS[8275] = Fluid3D([8501,8065,7926,7613],0); -ELEMENTS[8276] = Fluid3D([7926,8501,7613,8052],0); -ELEMENTS[8277] = Fluid3D([7613,7926,8052,7250],0); -ELEMENTS[8278] = Fluid3D([7613,7926,7250,7119],0); -ELEMENTS[8279] = Fluid3D([7613,7926,7119,8065],0); -ELEMENTS[8280] = Fluid3D([7926,8501,8052,8935],0); -ELEMENTS[8281] = Fluid3D([8501,8065,7613,8309],0); -ELEMENTS[8282] = Fluid3D([8065,8667,7926,7867],0); -ELEMENTS[8283] = Fluid3D([8065,8667,7867,8590],0); -ELEMENTS[8284] = Fluid3D([8667,7926,7867,8702],0); -ELEMENTS[8285] = Fluid3D([7926,8065,7867,7119],0); -ELEMENTS[8286] = Fluid3D([8501,7613,8052,7703],0); -ELEMENTS[8287] = Fluid3D([7613,8052,7703,7193],0); -ELEMENTS[8288] = Fluid3D([8501,7613,7703,8309],0); -ELEMENTS[8289] = Fluid3D([7613,7703,8309,7432],0); -ELEMENTS[8290] = Fluid3D([7703,7613,7193,6856],0); -ELEMENTS[8291] = Fluid3D([7703,7613,6856,7432],0); -ELEMENTS[8292] = Fluid3D([8667,9033,8702,7867],0); -ELEMENTS[8293] = Fluid3D([12147,11576,12057,12507],0); -ELEMENTS[8294] = Fluid3D([12147,12066,12549,12927],0); -ELEMENTS[8295] = Fluid3D([12147,12066,12927,12057],0); -ELEMENTS[8296] = Fluid3D([12549,12147,12927,12884],0); -ELEMENTS[8297] = Fluid3D([12066,12549,12927,12891],0); -ELEMENTS[8298] = Fluid3D([12927,12066,12891,12714],0); -ELEMENTS[8299] = Fluid3D([12066,12891,12714,12227],0); -ELEMENTS[8300] = Fluid3D([12066,12549,12891,11823],0); -ELEMENTS[8301] = Fluid3D([12066,12891,12227,11823],0); -ELEMENTS[8302] = Fluid3D([12927,12066,12714,12057],0); -ELEMENTS[8303] = Fluid3D([12549,12927,12891,13482],0); -ELEMENTS[8304] = Fluid3D([12549,12927,13482,12884],0); -ELEMENTS[8305] = Fluid3D([12927,12891,13482,13643],0); -ELEMENTS[8306] = Fluid3D([12891,13482,13643,13818],0); -ELEMENTS[8307] = Fluid3D([12891,13482,13818,12704],0); -ELEMENTS[8308] = Fluid3D([12891,12549,13482,12704],0); -ELEMENTS[8309] = Fluid3D([12927,12891,13643,12714],0); -ELEMENTS[8310] = Fluid3D([13482,12927,13643,13788],0); -ELEMENTS[8311] = Fluid3D([13482,12927,13788,12884],0); -ELEMENTS[8312] = Fluid3D([12927,13643,13788,13427],0); -ELEMENTS[8313] = Fluid3D([13643,13482,13788,14291],0); -ELEMENTS[8314] = Fluid3D([13643,13788,13427,14379],0); -ELEMENTS[8315] = Fluid3D([13643,13482,14291,13818],0); -ELEMENTS[8316] = Fluid3D([13643,13788,14379,14291],0); -ELEMENTS[8317] = Fluid3D([13788,13427,14379,14041],0); -ELEMENTS[8318] = Fluid3D([13788,13427,14041,13225],0); -ELEMENTS[8319] = Fluid3D([13788,13427,13225,12927],0); -ELEMENTS[8320] = Fluid3D([13427,14379,14041,14049],0); -ELEMENTS[8321] = Fluid3D([14041,13427,14049,13413],0); -ELEMENTS[8322] = Fluid3D([13427,14379,14049,13783],0); -ELEMENTS[8323] = Fluid3D([14041,13427,13413,13225],0); -ELEMENTS[8324] = Fluid3D([14379,13788,14041,14594],0); -ELEMENTS[8325] = Fluid3D([14041,14379,14594,14798],0); -ELEMENTS[8326] = Fluid3D([14041,14379,14798,14049],0); -ELEMENTS[8327] = Fluid3D([13427,14379,13783,13643],0); -ELEMENTS[8328] = Fluid3D([14379,13788,14594,14291],0); -ELEMENTS[8329] = Fluid3D([12927,13643,13427,12714],0); -ELEMENTS[8330] = Fluid3D([12891,12714,12227,13637],0); -ELEMENTS[8331] = Fluid3D([11118,12066,11447,12227],0); -ELEMENTS[8332] = Fluid3D([12714,12066,12227,11447],0); -ELEMENTS[8333] = Fluid3D([13482,13788,14291,14094],0); -ELEMENTS[8334] = Fluid3D([13482,13788,14094,12884],0); -ELEMENTS[8335] = Fluid3D([13788,14291,14094,14594],0); -ELEMENTS[8336] = Fluid3D([14291,13482,14094,14190],0); -ELEMENTS[8337] = Fluid3D([14291,13482,14190,13818],0); -ELEMENTS[8338] = Fluid3D([13482,14094,14190,13525],0); -ELEMENTS[8339] = Fluid3D([13482,14094,13525,12884],0); -ELEMENTS[8340] = Fluid3D([14190,13482,13525,13798],0); -ELEMENTS[8341] = Fluid3D([14190,13482,13798,13818],0); -ELEMENTS[8342] = Fluid3D([13482,13525,13798,12704],0); -ELEMENTS[8343] = Fluid3D([14094,14190,13525,14390],0); -ELEMENTS[8344] = Fluid3D([13525,14094,14390,13850],0); -ELEMENTS[8345] = Fluid3D([14190,13525,14390,14032],0); -ELEMENTS[8346] = Fluid3D([13525,14390,14032,13738],0); -ELEMENTS[8347] = Fluid3D([14190,13525,14032,13798],0); -ELEMENTS[8348] = Fluid3D([13525,14390,13738,13850],0); -ELEMENTS[8349] = Fluid3D([14094,14190,14390,14882],0); -ELEMENTS[8350] = Fluid3D([14190,14390,14882,14032],0); -ELEMENTS[8351] = Fluid3D([14094,14390,13850,14656],0); -ELEMENTS[8352] = Fluid3D([14390,13850,14656,14437],0); -ELEMENTS[8353] = Fluid3D([13850,14094,14656,14158],0); -ELEMENTS[8354] = Fluid3D([14656,14390,14437,15093],0); -ELEMENTS[8355] = Fluid3D([13850,14094,14158,12884],0); -ELEMENTS[8356] = Fluid3D([14094,14390,14656,14882],0); -ELEMENTS[8357] = Fluid3D([14656,14390,15093,14882],0); -ELEMENTS[8358] = Fluid3D([14390,15093,14882,15108],0); -ELEMENTS[8359] = Fluid3D([13525,14094,13850,12884],0); -ELEMENTS[8360] = Fluid3D([14390,13850,14437,13738],0); -ELEMENTS[8361] = Fluid3D([14094,14291,14190,14815],0); -ELEMENTS[8362] = Fluid3D([14094,14291,14815,14594],0); -ELEMENTS[8363] = Fluid3D([14291,14190,14815,14996],0); -ELEMENTS[8364] = Fluid3D([14291,14190,14996,13818],0); -ELEMENTS[8365] = Fluid3D([14815,14291,14996,15061],0); -ELEMENTS[8366] = Fluid3D([14291,14996,15061,14604],0); -ELEMENTS[8367] = Fluid3D([14291,14996,14604,13818],0); -ELEMENTS[8368] = Fluid3D([14996,15061,14604,15329],0); -ELEMENTS[8369] = Fluid3D([15061,14604,15329,15175],0); -ELEMENTS[8370] = Fluid3D([15061,14604,15175,14379],0); -ELEMENTS[8371] = Fluid3D([14996,15061,15329,15362],0); -ELEMENTS[8372] = Fluid3D([14996,15061,15362,14815],0); -ELEMENTS[8373] = Fluid3D([15061,15329,15362,15768],0); -ELEMENTS[8374] = Fluid3D([15362,15061,15768,15566],0); -ELEMENTS[8375] = Fluid3D([15362,15061,15566,14815],0); -ELEMENTS[8376] = Fluid3D([15061,15329,15768,15175],0); -ELEMENTS[8377] = Fluid3D([14815,14291,15061,14594],0); -ELEMENTS[8378] = Fluid3D([15329,15362,15768,15871],0); -ELEMENTS[8379] = Fluid3D([15362,15768,15871,15780],0); -ELEMENTS[8380] = Fluid3D([15362,15768,15780,15566],0); -ELEMENTS[8381] = Fluid3D([15780,15362,15566,14815],0); -ELEMENTS[8382] = Fluid3D([15871,15362,15780,15526],0); -ELEMENTS[8383] = Fluid3D([15329,15362,15871,15526],0); -ELEMENTS[8384] = Fluid3D([15768,15329,15871,15836],0); -ELEMENTS[8385] = Fluid3D([15768,15329,15836,15175],0); -ELEMENTS[8386] = Fluid3D([15329,15871,15836,15510],0); -ELEMENTS[8387] = Fluid3D([15871,15836,15510,16227],0); -ELEMENTS[8388] = Fluid3D([15871,15836,16227,16591],0); -ELEMENTS[8389] = Fluid3D([15836,15329,15510,15399],0); -ELEMENTS[8390] = Fluid3D([15836,15329,15399,15175],0); -ELEMENTS[8391] = Fluid3D([15329,15510,15399,15039],0); -ELEMENTS[8392] = Fluid3D([15329,15871,15510,15526],0); -ELEMENTS[8393] = Fluid3D([15510,15399,15039,15364],0); -ELEMENTS[8394] = Fluid3D([15329,15510,15039,15237],0); -ELEMENTS[8395] = Fluid3D([15329,15510,15237,15526],0); -ELEMENTS[8396] = Fluid3D([15510,15039,15237,15138],0); -ELEMENTS[8397] = Fluid3D([15039,15329,15237,14996],0); -ELEMENTS[8398] = Fluid3D([15871,15768,15836,16147],0); -ELEMENTS[8399] = Fluid3D([15871,15768,16147,15780],0); -ELEMENTS[8400] = Fluid3D([15768,16147,15780,15566],0); -ELEMENTS[8401] = Fluid3D([15768,16147,15566,15918],0); -ELEMENTS[8402] = Fluid3D([15768,16147,15918,16368],0); -ELEMENTS[8403] = Fluid3D([15566,15768,15918,15061],0); -ELEMENTS[8404] = Fluid3D([14190,14815,14996,14882],0); -ELEMENTS[8405] = Fluid3D([14190,14815,14882,14094],0); -ELEMENTS[8406] = Fluid3D([14041,13788,13225,13847],0); -ELEMENTS[8407] = Fluid3D([13788,13225,13847,12884],0); -ELEMENTS[8408] = Fluid3D([14041,13788,13847,14594],0); -ELEMENTS[8409] = Fluid3D([13225,14041,13847,13708],0); -ELEMENTS[8410] = Fluid3D([13225,14041,13708,13413],0); -ELEMENTS[8411] = Fluid3D([14041,13847,13708,14416],0); -ELEMENTS[8412] = Fluid3D([13708,14041,14416,14263],0); -ELEMENTS[8413] = Fluid3D([13708,14041,14263,13413],0); -ELEMENTS[8414] = Fluid3D([14041,13847,14416,14594],0); -ELEMENTS[8415] = Fluid3D([13847,13225,13708,13215],0); -ELEMENTS[8416] = Fluid3D([13225,13708,13215,12507],0); -ELEMENTS[8417] = Fluid3D([13215,13225,12507,12884],0); -ELEMENTS[8418] = Fluid3D([13708,13847,13215,14219],0); -ELEMENTS[8419] = Fluid3D([13215,13708,14219,13355],0); -ELEMENTS[8420] = Fluid3D([13215,13708,13355,12507],0); -ELEMENTS[8421] = Fluid3D([13708,13847,14219,14416],0); -ELEMENTS[8422] = Fluid3D([13847,13225,13215,12884],0); -ELEMENTS[8423] = Fluid3D([13847,13215,14219,14158],0); -ELEMENTS[8424] = Fluid3D([14219,13847,14158,14416],0); -ELEMENTS[8425] = Fluid3D([13847,13215,14158,12884],0); -ELEMENTS[8426] = Fluid3D([14041,14416,14263,14798],0); -ELEMENTS[8427] = Fluid3D([14219,13215,13355,13370],0); -ELEMENTS[8428] = Fluid3D([13215,13355,13370,12554],0); -ELEMENTS[8429] = Fluid3D([13355,13370,12554,12797],0); -ELEMENTS[8430] = Fluid3D([13355,14219,13370,13873],0); -ELEMENTS[8431] = Fluid3D([13355,14219,13873,14192],0); -ELEMENTS[8432] = Fluid3D([14219,13215,13370,13734],0); -ELEMENTS[8433] = Fluid3D([13355,14219,14192,13708],0); -ELEMENTS[8434] = Fluid3D([13370,12554,12797,12588],0); -ELEMENTS[8435] = Fluid3D([13370,12554,12588,12706],0); -ELEMENTS[8436] = Fluid3D([12797,13370,12588,13414],0); -ELEMENTS[8437] = Fluid3D([13370,12554,12706,13215],0); -ELEMENTS[8438] = Fluid3D([14219,13215,13734,14158],0); -ELEMENTS[8439] = Fluid3D([12797,13370,13414,13873],0); -ELEMENTS[8440] = Fluid3D([13734,14219,14158,14548],0); -ELEMENTS[8441] = Fluid3D([14158,13734,14548,14087],0); -ELEMENTS[8442] = Fluid3D([14158,13734,14087,13850],0); -ELEMENTS[8443] = Fluid3D([14087,14158,13850,14656],0); -ELEMENTS[8444] = Fluid3D([13850,14087,14656,14437],0); -ELEMENTS[8445] = Fluid3D([13850,14087,14437,13256],0); -ELEMENTS[8446] = Fluid3D([13850,14087,13256,13734],0); -ELEMENTS[8447] = Fluid3D([13734,14548,14087,14011],0); -ELEMENTS[8448] = Fluid3D([13734,14548,14011,13370],0); -ELEMENTS[8449] = Fluid3D([14087,13734,14011,13256],0); -ELEMENTS[8450] = Fluid3D([14087,14158,14656,14548],0); -ELEMENTS[8451] = Fluid3D([14548,14087,14011,15015],0); -ELEMENTS[8452] = Fluid3D([13734,14219,14548,13370],0); -ELEMENTS[8453] = Fluid3D([13215,13355,12554,12507],0); -ELEMENTS[8454] = Fluid3D([13355,13370,12797,13873],0); -ELEMENTS[8455] = Fluid3D([14390,14032,13738,14226],0); -ELEMENTS[8456] = Fluid3D([14032,13738,14226,13310],0); -ELEMENTS[8457] = Fluid3D([13738,14390,14226,14437],0); -ELEMENTS[8458] = Fluid3D([12554,13355,12797,12530],0); -ELEMENTS[8459] = Fluid3D([12554,13355,12530,12607],0); -ELEMENTS[8460] = Fluid3D([12797,12554,12530,11790],0); -ELEMENTS[8461] = Fluid3D([13355,12797,12530,13397],0); -ELEMENTS[8462] = Fluid3D([12530,13355,13397,13221],0); -ELEMENTS[8463] = Fluid3D([13355,12797,13397,13873],0); -ELEMENTS[8464] = Fluid3D([13355,13397,13221,14192],0); -ELEMENTS[8465] = Fluid3D([12797,12530,13397,12713],0); -ELEMENTS[8466] = Fluid3D([12530,13397,12713,12700],0); -ELEMENTS[8467] = Fluid3D([13397,12797,12713,13401],0); -ELEMENTS[8468] = Fluid3D([12797,12530,12713,11913],0); -ELEMENTS[8469] = Fluid3D([12797,12713,13401,12648],0); -ELEMENTS[8470] = Fluid3D([12797,12713,12648,11913],0); -ELEMENTS[8471] = Fluid3D([12713,12648,11913,12295],0); -ELEMENTS[8472] = Fluid3D([12648,11913,12295,11805],0); -ELEMENTS[8473] = Fluid3D([12295,12648,11805,12587],0); -ELEMENTS[8474] = Fluid3D([12295,12648,12587,13060],0); -ELEMENTS[8475] = Fluid3D([12295,12648,13060,12713],0); -ELEMENTS[8476] = Fluid3D([12648,11913,11805,12053],0); -ELEMENTS[8477] = Fluid3D([12648,11913,12053,12797],0); -ELEMENTS[8478] = Fluid3D([12648,11805,12587,12505],0); -ELEMENTS[8479] = Fluid3D([12648,12587,13060,13340],0); -ELEMENTS[8480] = Fluid3D([11805,12648,12053,12505],0); -ELEMENTS[8481] = Fluid3D([12587,12648,12505,13340],0); -ELEMENTS[8482] = Fluid3D([13060,12648,13340,13401],0); -ELEMENTS[8483] = Fluid3D([13060,12648,13401,12713],0); -ELEMENTS[8484] = Fluid3D([11805,12295,12587,11775],0); -ELEMENTS[8485] = Fluid3D([12587,12295,13060,12544],0); -ELEMENTS[8486] = Fluid3D([12648,12053,12505,12588],0); -ELEMENTS[8487] = Fluid3D([12053,12505,12588,11820],0); -ELEMENTS[8488] = Fluid3D([12588,12053,11820,11790],0); -ELEMENTS[8489] = Fluid3D([12588,12053,11790,12797],0); -ELEMENTS[8490] = Fluid3D([12588,12053,12797,12648],0); -ELEMENTS[8491] = Fluid3D([12505,12588,11820,12702],0); -ELEMENTS[8492] = Fluid3D([12588,11820,12702,11978],0); -ELEMENTS[8493] = Fluid3D([12505,12588,12702,13414],0); -ELEMENTS[8494] = Fluid3D([12053,12505,11820,11364],0); -ELEMENTS[8495] = Fluid3D([11820,12053,11364,11135],0); -ELEMENTS[8496] = Fluid3D([11364,11820,11135,10612],0); -ELEMENTS[8497] = Fluid3D([11820,12053,11135,11790],0); -ELEMENTS[8498] = Fluid3D([12053,11135,11790,11042],0); -ELEMENTS[8499] = Fluid3D([11135,11790,11042,10928],0); -ELEMENTS[8500] = Fluid3D([11790,12053,11042,11637],0); -ELEMENTS[8501] = Fluid3D([12295,13060,12544,12867],0); -ELEMENTS[8502] = Fluid3D([12295,13060,12867,12278],0); -ELEMENTS[8503] = Fluid3D([12587,12295,12544,11775],0); -ELEMENTS[8504] = Fluid3D([11805,12295,11775,11419],0); -ELEMENTS[8505] = Fluid3D([12544,12295,12867,12090],0); -ELEMENTS[8506] = Fluid3D([12295,12867,12090,12278],0); -ELEMENTS[8507] = Fluid3D([12867,12090,12278,12576],0); -ELEMENTS[8508] = Fluid3D([12867,12090,12576,12535],0); -ELEMENTS[8509] = Fluid3D([12867,12090,12535,12544],0); -ELEMENTS[8510] = Fluid3D([12090,12576,12535,11830],0); -ELEMENTS[8511] = Fluid3D([12090,12576,11830,11582],0); -ELEMENTS[8512] = Fluid3D([12535,12090,11830,11770],0); -ELEMENTS[8513] = Fluid3D([12535,12090,11770,12544],0); -ELEMENTS[8514] = Fluid3D([12576,12867,12535,13415],0); -ELEMENTS[8515] = Fluid3D([12867,12535,13415,13253],0); -ELEMENTS[8516] = Fluid3D([12867,12535,13253,12544],0); -ELEMENTS[8517] = Fluid3D([12090,11830,11770,11006],0); -ELEMENTS[8518] = Fluid3D([11830,12090,11582,11006],0); -ELEMENTS[8519] = Fluid3D([12576,12867,13415,13263],0); -ELEMENTS[8520] = Fluid3D([13415,12867,13253,13822],0); -ELEMENTS[8521] = Fluid3D([12867,13415,13263,13822],0); -ELEMENTS[8522] = Fluid3D([11913,12295,11805,11419],0); -ELEMENTS[8523] = Fluid3D([12867,13253,13822,13060],0); -ELEMENTS[8524] = Fluid3D([13822,12867,13060,13263],0); -ELEMENTS[8525] = Fluid3D([12576,12867,13263,12278],0); -ELEMENTS[8526] = Fluid3D([12053,11805,12505,11364],0); -ELEMENTS[8527] = Fluid3D([12053,11805,11364,11042],0); -ELEMENTS[8528] = Fluid3D([11805,12505,11364,11900],0); -ELEMENTS[8529] = Fluid3D([11913,11805,12053,11042],0); -ELEMENTS[8530] = Fluid3D([12053,11913,11042,11637],0); -ELEMENTS[8531] = Fluid3D([11913,11805,11042,11419],0); -ELEMENTS[8532] = Fluid3D([12587,11805,11775,11900],0); -ELEMENTS[8533] = Fluid3D([12576,12535,11830,12678],0); -ELEMENTS[8534] = Fluid3D([11830,12576,12678,12080],0); -ELEMENTS[8535] = Fluid3D([11830,12576,12080,11582],0); -ELEMENTS[8536] = Fluid3D([12535,11830,12678,12323],0); -ELEMENTS[8537] = Fluid3D([12535,11830,12323,11770],0); -ELEMENTS[8538] = Fluid3D([11830,12678,12323,11794],0); -ELEMENTS[8539] = Fluid3D([11830,12678,11794,12080],0); -ELEMENTS[8540] = Fluid3D([13253,13415,13822,14137],0); -ELEMENTS[8541] = Fluid3D([13415,13822,14137,14033],0); -ELEMENTS[8542] = Fluid3D([13415,13822,14033,13263],0); -ELEMENTS[8543] = Fluid3D([12323,11830,11794,11206],0); -ELEMENTS[8544] = Fluid3D([12323,11830,11206,11770],0); -ELEMENTS[8545] = Fluid3D([12535,13415,13253,13445],0); -ELEMENTS[8546] = Fluid3D([13253,12535,13445,12985],0); -ELEMENTS[8547] = Fluid3D([13253,12535,12985,12544],0); -ELEMENTS[8548] = Fluid3D([12535,13415,13445,12678],0); -ELEMENTS[8549] = Fluid3D([13060,12544,12867,13253],0); -ELEMENTS[8550] = Fluid3D([12587,13060,13340,13515],0); -ELEMENTS[8551] = Fluid3D([13340,12587,13515,13016],0); -ELEMENTS[8552] = Fluid3D([13060,13340,13515,14030],0); -ELEMENTS[8553] = Fluid3D([13060,13340,14030,13401],0); -ELEMENTS[8554] = Fluid3D([13515,13340,13016,13965],0); -ELEMENTS[8555] = Fluid3D([13515,13340,13965,14030],0); -ELEMENTS[8556] = Fluid3D([13340,13016,13965,13517],0); -ELEMENTS[8557] = Fluid3D([13340,13016,13517,12505],0); -ELEMENTS[8558] = Fluid3D([13340,12587,13016,12505],0); -ELEMENTS[8559] = Fluid3D([12535,13445,12985,12323],0); -ELEMENTS[8560] = Fluid3D([11805,12587,12505,11900],0); -ELEMENTS[8561] = Fluid3D([13060,12587,12544,13515],0); -ELEMENTS[8562] = Fluid3D([13445,13253,12985,13812],0); -ELEMENTS[8563] = Fluid3D([13253,12985,13812,13245],0); -ELEMENTS[8564] = Fluid3D([13253,12985,13245,12544],0); -ELEMENTS[8565] = Fluid3D([13445,13253,13812,14137],0); -ELEMENTS[8566] = Fluid3D([12648,12505,13340,13414],0); -ELEMENTS[8567] = Fluid3D([12505,13340,13414,13517],0); -ELEMENTS[8568] = Fluid3D([13340,13414,13517,14134],0); -ELEMENTS[8569] = Fluid3D([13340,13414,14134,13401],0); -ELEMENTS[8570] = Fluid3D([13414,13517,14134,13998],0); -ELEMENTS[8571] = Fluid3D([13414,13517,13998,12702],0); -ELEMENTS[8572] = Fluid3D([14134,13414,13998,13873],0); -ELEMENTS[8573] = Fluid3D([13517,13340,14134,13965],0); -ELEMENTS[8574] = Fluid3D([13340,14134,13965,14030],0); -ELEMENTS[8575] = Fluid3D([14134,13517,13965,14342],0); -ELEMENTS[8576] = Fluid3D([13965,14134,14342,14755],0); -ELEMENTS[8577] = Fluid3D([13965,14134,14755,14030],0); -ELEMENTS[8578] = Fluid3D([14342,13965,14755,14530],0); -ELEMENTS[8579] = Fluid3D([14134,14342,14755,14733],0); -ELEMENTS[8580] = Fluid3D([13965,14755,14530,14470],0); -ELEMENTS[8581] = Fluid3D([14755,14134,14733,14779],0); -ELEMENTS[8582] = Fluid3D([13965,14755,14470,14030],0); -ELEMENTS[8583] = Fluid3D([14755,14134,14779,14030],0); -ELEMENTS[8584] = Fluid3D([14342,13965,14530,13794],0); -ELEMENTS[8585] = Fluid3D([14342,13965,13794,13517],0); -ELEMENTS[8586] = Fluid3D([14134,14342,14733,13998],0); -ELEMENTS[8587] = Fluid3D([14530,13965,14470,13880],0); -ELEMENTS[8588] = Fluid3D([13965,14530,13794,13880],0); -ELEMENTS[8589] = Fluid3D([14134,14733,14779,14451],0); -ELEMENTS[8590] = Fluid3D([14134,14733,14451,13998],0); -ELEMENTS[8591] = Fluid3D([13965,14470,13880,13515],0); -ELEMENTS[8592] = Fluid3D([14779,14134,14451,14013],0); -ELEMENTS[8593] = Fluid3D([14779,14134,14013,14030],0); -ELEMENTS[8594] = Fluid3D([14134,14013,14030,13401],0); -ELEMENTS[8595] = Fluid3D([14013,14030,13401,14209],0); -ELEMENTS[8596] = Fluid3D([13401,14013,14209,14184],0); -ELEMENTS[8597] = Fluid3D([13401,14013,14184,13873],0); -ELEMENTS[8598] = Fluid3D([14013,14184,13873,14677],0); -ELEMENTS[8599] = Fluid3D([13873,14013,14677,14451],0); -ELEMENTS[8600] = Fluid3D([14677,13873,14451,14641],0); -ELEMENTS[8601] = Fluid3D([13873,14451,14641,14219],0); -ELEMENTS[8602] = Fluid3D([13873,14013,14451,14134],0); -ELEMENTS[8603] = Fluid3D([14641,13873,14219,14192],0); -ELEMENTS[8604] = Fluid3D([14219,14641,14192,14416],0); -ELEMENTS[8605] = Fluid3D([14451,14677,14641,15131],0); -ELEMENTS[8606] = Fluid3D([14451,14677,15131,14779],0); -ELEMENTS[8607] = Fluid3D([14451,14677,14779,14013],0); -ELEMENTS[8608] = Fluid3D([14013,14209,14184,14677],0); -ELEMENTS[8609] = Fluid3D([14641,13873,14192,14677],0); -ELEMENTS[8610] = Fluid3D([14641,14451,15131,14548],0); -ELEMENTS[8611] = Fluid3D([14677,14779,14013,14209],0); -ELEMENTS[8612] = Fluid3D([14013,14030,14209,14779],0); -ELEMENTS[8613] = Fluid3D([13401,14013,13873,13414],0); -ELEMENTS[8614] = Fluid3D([14184,13873,14677,14192],0); -ELEMENTS[8615] = Fluid3D([14677,14641,15131,15216],0); -ELEMENTS[8616] = Fluid3D([15131,14677,15216,15473],0); -ELEMENTS[8617] = Fluid3D([15131,14677,15473,14779],0); -ELEMENTS[8618] = Fluid3D([14209,13401,14184,13263],0); -ELEMENTS[8619] = Fluid3D([14733,14755,14779,15387],0); -ELEMENTS[8620] = Fluid3D([14755,14779,15387,15163],0); -ELEMENTS[8621] = Fluid3D([13517,14134,13998,14342],0); -ELEMENTS[8622] = Fluid3D([14677,14641,15216,14192],0); -ELEMENTS[8623] = Fluid3D([14755,14779,15163,14030],0); -ELEMENTS[8624] = Fluid3D([14733,14755,15387,15205],0); -ELEMENTS[8625] = Fluid3D([14733,14755,15205,14342],0); -ELEMENTS[8626] = Fluid3D([14755,15387,15205,15401],0); -ELEMENTS[8627] = Fluid3D([15205,14755,15401,14530],0); -ELEMENTS[8628] = Fluid3D([14755,15387,15401,15163],0); -ELEMENTS[8629] = Fluid3D([14470,14530,13880,14760],0); -ELEMENTS[8630] = Fluid3D([14530,13880,14760,14178],0); -ELEMENTS[8631] = Fluid3D([14530,13880,14178,13794],0); -ELEMENTS[8632] = Fluid3D([14677,15216,15473,14967],0); -ELEMENTS[8633] = Fluid3D([15473,14677,14967,14939],0); -ELEMENTS[8634] = Fluid3D([14677,15216,14967,14192],0); -ELEMENTS[8635] = Fluid3D([15473,14677,14939,14779],0); -ELEMENTS[8636] = Fluid3D([14677,14939,14779,14209],0); -ELEMENTS[8637] = Fluid3D([14677,14967,14939,14184],0); -ELEMENTS[8638] = Fluid3D([14530,14342,13794,14495],0); -ELEMENTS[8639] = Fluid3D([14342,13794,14495,13901],0); -ELEMENTS[8640] = Fluid3D([14342,13794,13901,13517],0); -ELEMENTS[8641] = Fluid3D([14530,14342,14495,15205],0); -ELEMENTS[8642] = Fluid3D([14495,14342,13901,14741],0); -ELEMENTS[8643] = Fluid3D([14495,14342,14741,15205],0); -ELEMENTS[8644] = Fluid3D([14342,13901,14741,13998],0); -ELEMENTS[8645] = Fluid3D([13794,14495,13901,13593],0); -ELEMENTS[8646] = Fluid3D([13901,13794,13593,13146],0); -ELEMENTS[8647] = Fluid3D([13901,13794,13146,13517],0); -ELEMENTS[8648] = Fluid3D([14755,14342,14530,15205],0); -ELEMENTS[8649] = Fluid3D([14779,15387,15163,15473],0); -ELEMENTS[8650] = Fluid3D([14755,14530,14470,15401],0); -ELEMENTS[8651] = Fluid3D([14641,15131,15216,15622],0); -ELEMENTS[8652] = Fluid3D([15131,15216,15622,15473],0); -ELEMENTS[8653] = Fluid3D([12090,12278,12576,11582],0); -ELEMENTS[8654] = Fluid3D([13415,12576,13263,13302],0); -ELEMENTS[8655] = Fluid3D([12576,13263,13302,12734],0); -ELEMENTS[8656] = Fluid3D([12576,13263,12734,12278],0); -ELEMENTS[8657] = Fluid3D([14733,14779,14451,15131],0); -ELEMENTS[8658] = Fluid3D([12985,13812,13245,13311],0); -ELEMENTS[8659] = Fluid3D([12535,12576,13415,12678],0); -ELEMENTS[8660] = Fluid3D([13397,12797,13401,13873],0); -ELEMENTS[8661] = Fluid3D([11820,12505,12702,11900],0); -ELEMENTS[8662] = Fluid3D([13397,12713,12700,13200],0); -ELEMENTS[8663] = Fluid3D([13397,12713,13200,13401],0); -ELEMENTS[8664] = Fluid3D([12713,12700,13200,12278],0); -ELEMENTS[8665] = Fluid3D([12700,13397,13200,13647],0); -ELEMENTS[8666] = Fluid3D([12700,13397,13647,13221],0); -ELEMENTS[8667] = Fluid3D([13397,13200,13647,14184],0); -ELEMENTS[8668] = Fluid3D([13647,13397,14184,14192],0); -ELEMENTS[8669] = Fluid3D([13397,13200,14184,13401],0); -ELEMENTS[8670] = Fluid3D([14184,13397,13401,13873],0); -ELEMENTS[8671] = Fluid3D([14184,13397,13873,14192],0); -ELEMENTS[8672] = Fluid3D([12530,13355,13221,12607],0); -ELEMENTS[8673] = Fluid3D([13221,12530,12607,12700],0); -ELEMENTS[8674] = Fluid3D([12530,13397,12700,13221],0); -ELEMENTS[8675] = Fluid3D([13200,12700,13647,13068],0); -ELEMENTS[8676] = Fluid3D([12700,13647,13068,12945],0); -ELEMENTS[8677] = Fluid3D([13647,13068,12945,13747],0); -ELEMENTS[8678] = Fluid3D([13647,13068,13747,13915],0); -ELEMENTS[8679] = Fluid3D([13647,13068,13915,13200],0); -ELEMENTS[8680] = Fluid3D([12945,13647,13747,13897],0); -ELEMENTS[8681] = Fluid3D([12945,13647,13897,13221],0); -ELEMENTS[8682] = Fluid3D([13747,12945,13897,13496],0); -ELEMENTS[8683] = Fluid3D([12945,13897,13496,13328],0); -ELEMENTS[8684] = Fluid3D([12945,13897,13328,13221],0); -ELEMENTS[8685] = Fluid3D([13747,12945,13496,12972],0); -ELEMENTS[8686] = Fluid3D([12945,13496,12972,12729],0); -ELEMENTS[8687] = Fluid3D([12945,13496,12729,13328],0); -ELEMENTS[8688] = Fluid3D([13747,12945,12972,13068],0); -ELEMENTS[8689] = Fluid3D([13200,12700,13068,12734],0); -ELEMENTS[8690] = Fluid3D([13068,13200,12734,13915],0); -ELEMENTS[8691] = Fluid3D([12700,13068,12734,12241],0); -ELEMENTS[8692] = Fluid3D([13068,12734,12241,12859],0); -ELEMENTS[8693] = Fluid3D([13068,12734,12859,13477],0); -ELEMENTS[8694] = Fluid3D([13068,12734,13477,13915],0); -ELEMENTS[8695] = Fluid3D([13477,13068,13915,13747],0); -ELEMENTS[8696] = Fluid3D([12241,13068,12859,12972],0); -ELEMENTS[8697] = Fluid3D([12859,13068,13477,13747],0); -ELEMENTS[8698] = Fluid3D([12734,12859,13477,13302],0); -ELEMENTS[8699] = Fluid3D([13477,12734,13302,13263],0); -ELEMENTS[8700] = Fluid3D([13302,13477,13263,14033],0); -ELEMENTS[8701] = Fluid3D([12859,13477,13302,13339],0); -ELEMENTS[8702] = Fluid3D([13477,13302,13339,14089],0); -ELEMENTS[8703] = Fluid3D([13477,13302,14089,14033],0); -ELEMENTS[8704] = Fluid3D([13339,13477,14089,13787],0); -ELEMENTS[8705] = Fluid3D([13339,13477,13787,12859],0); -ELEMENTS[8706] = Fluid3D([13477,14089,13787,13915],0); -ELEMENTS[8707] = Fluid3D([13787,13477,13915,13747],0); -ELEMENTS[8708] = Fluid3D([13477,14089,13915,14033],0); -ELEMENTS[8709] = Fluid3D([13302,13339,14089,13596],0); -ELEMENTS[8710] = Fluid3D([14089,13302,13596,14033],0); -ELEMENTS[8711] = Fluid3D([12734,12241,12859,11874],0); -ELEMENTS[8712] = Fluid3D([12859,12734,11874,12080],0); -ELEMENTS[8713] = Fluid3D([14089,13339,13787,14208],0); -ELEMENTS[8714] = Fluid3D([13339,13787,14208,13510],0); -ELEMENTS[8715] = Fluid3D([13339,13787,13510,12859],0); -ELEMENTS[8716] = Fluid3D([13787,14208,13510,14414],0); -ELEMENTS[8717] = Fluid3D([13787,14089,14208,14738],0); -ELEMENTS[8718] = Fluid3D([14208,13787,14738,14414],0); -ELEMENTS[8719] = Fluid3D([13510,13787,14414,13846],0); -ELEMENTS[8720] = Fluid3D([13510,13787,13846,13220],0); -ELEMENTS[8721] = Fluid3D([13510,13787,13220,12859],0); -ELEMENTS[8722] = Fluid3D([13787,13846,13220,13747],0); -ELEMENTS[8723] = Fluid3D([13787,14089,14738,13915],0); -ELEMENTS[8724] = Fluid3D([13787,14414,13846,14657],0); -ELEMENTS[8725] = Fluid3D([13787,14414,14657,14738],0); -ELEMENTS[8726] = Fluid3D([13846,13787,14657,13747],0); -ELEMENTS[8727] = Fluid3D([14208,13510,14414,14285],0); -ELEMENTS[8728] = Fluid3D([12700,13068,12241,12945],0); -ELEMENTS[8729] = Fluid3D([13068,12859,12972,13747],0); -ELEMENTS[8730] = Fluid3D([12241,12859,11874,11875],0); -ELEMENTS[8731] = Fluid3D([12859,11874,11875,12187],0); -ELEMENTS[8732] = Fluid3D([12859,11874,12187,12080],0); -ELEMENTS[8733] = Fluid3D([11874,11875,12187,10978],0); -ELEMENTS[8734] = Fluid3D([12187,11874,10978,12080],0); -ELEMENTS[8735] = Fluid3D([11875,12859,12187,12717],0); -ELEMENTS[8736] = Fluid3D([12859,12187,12717,13339],0); -ELEMENTS[8737] = Fluid3D([11874,11875,10978,11168],0); -ELEMENTS[8738] = Fluid3D([11875,12859,12717,12972],0); -ELEMENTS[8739] = Fluid3D([11874,11875,11168,12241],0); -ELEMENTS[8740] = Fluid3D([12187,11875,12717,11664],0); -ELEMENTS[8741] = Fluid3D([12717,12187,11664,12378],0); -ELEMENTS[8742] = Fluid3D([12717,12187,12378,12942],0); -ELEMENTS[8743] = Fluid3D([12717,12187,12942,13339],0); -ELEMENTS[8744] = Fluid3D([11875,12717,11664,12019],0); -ELEMENTS[8745] = Fluid3D([12717,11664,12019,12504],0); -ELEMENTS[8746] = Fluid3D([12717,11664,12504,12378],0); -ELEMENTS[8747] = Fluid3D([11875,12717,12019,12972],0); -ELEMENTS[8748] = Fluid3D([12187,11875,11664,10978],0); -ELEMENTS[8749] = Fluid3D([13647,13747,13897,14430],0); -ELEMENTS[8750] = Fluid3D([13747,13897,14430,14363],0); -ELEMENTS[8751] = Fluid3D([13897,13647,14430,14294],0); -ELEMENTS[8752] = Fluid3D([13897,13647,14294,13221],0); -ELEMENTS[8753] = Fluid3D([13647,13747,14430,13915],0); -ELEMENTS[8754] = Fluid3D([13897,14430,14363,14666],0); -ELEMENTS[8755] = Fluid3D([13897,14430,14666,14294],0); -ELEMENTS[8756] = Fluid3D([14430,14363,14666,15049],0); -ELEMENTS[8757] = Fluid3D([14363,13897,14666,13981],0); -ELEMENTS[8758] = Fluid3D([14666,14430,15049,15124],0); -ELEMENTS[8759] = Fluid3D([14666,14430,15124,14294],0); -ELEMENTS[8760] = Fluid3D([14430,14363,15049,14657],0); -ELEMENTS[8761] = Fluid3D([14363,13897,13981,13496],0); -ELEMENTS[8762] = Fluid3D([13647,14430,14294,14184],0); -ELEMENTS[8763] = Fluid3D([13747,13897,14363,13496],0); -ELEMENTS[8764] = Fluid3D([12700,13647,12945,13221],0); -ELEMENTS[8765] = Fluid3D([11664,11875,12019,11071],0); -ELEMENTS[8766] = Fluid3D([11875,12019,11071,11686],0); -ELEMENTS[8767] = Fluid3D([12019,11071,11686,11301],0); -ELEMENTS[8768] = Fluid3D([12019,11071,11301,11219],0); -ELEMENTS[8769] = Fluid3D([12019,11071,11219,11664],0); -ELEMENTS[8770] = Fluid3D([11071,11686,11301,10660],0); -ELEMENTS[8771] = Fluid3D([11071,11686,10660,11168],0); -ELEMENTS[8772] = Fluid3D([11686,11301,10660,11369],0); -ELEMENTS[8773] = Fluid3D([11301,10660,11369,10597],0); -ELEMENTS[8774] = Fluid3D([11301,10660,10597,10303],0); -ELEMENTS[8775] = Fluid3D([11301,10660,10303,11071],0); -ELEMENTS[8776] = Fluid3D([11686,11301,11369,12194],0); -ELEMENTS[8777] = Fluid3D([11301,11369,12194,11485],0); -ELEMENTS[8778] = Fluid3D([11301,11369,11485,10597],0); -ELEMENTS[8779] = Fluid3D([11686,11301,12194,12019],0); -ELEMENTS[8780] = Fluid3D([11664,11875,11071,10978],0); -ELEMENTS[8781] = Fluid3D([11071,11301,11219,10303],0); -ELEMENTS[8782] = Fluid3D([11369,11686,12194,12729],0); -ELEMENTS[8783] = Fluid3D([11686,12194,12729,12019],0); -ELEMENTS[8784] = Fluid3D([11071,11875,11686,11168],0); -ELEMENTS[8785] = Fluid3D([11875,12019,11686,12972],0); -ELEMENTS[8786] = Fluid3D([14414,13510,13846,14151],0); -ELEMENTS[8787] = Fluid3D([13510,13846,14151,13176],0); -ELEMENTS[8788] = Fluid3D([14414,13510,14151,14285],0); -ELEMENTS[8789] = Fluid3D([13846,14151,13176,13772],0); -ELEMENTS[8790] = Fluid3D([13176,13846,13772,13204],0); -ELEMENTS[8791] = Fluid3D([13176,13846,13204,13220],0); -ELEMENTS[8792] = Fluid3D([13846,14151,13772,14531],0); -ELEMENTS[8793] = Fluid3D([13846,14151,14531,14414],0); -ELEMENTS[8794] = Fluid3D([14151,13772,14531,14359],0); -ELEMENTS[8795] = Fluid3D([14531,14151,14359,14830],0); -ELEMENTS[8796] = Fluid3D([14531,14151,14830,14414],0); -ELEMENTS[8797] = Fluid3D([14151,13772,14359,13558],0); -ELEMENTS[8798] = Fluid3D([14151,13772,13558,13176],0); -ELEMENTS[8799] = Fluid3D([13772,14531,14359,14432],0); -ELEMENTS[8800] = Fluid3D([14531,14359,14432,15064],0); -ELEMENTS[8801] = Fluid3D([14531,14359,15064,14830],0); -ELEMENTS[8802] = Fluid3D([13772,14531,14432,14150],0); -ELEMENTS[8803] = Fluid3D([13772,14359,13558,13784],0); -ELEMENTS[8804] = Fluid3D([13772,14531,14150,13846],0); -ELEMENTS[8805] = Fluid3D([13772,14359,13784,14432],0); -ELEMENTS[8806] = Fluid3D([14432,13772,14150,13674],0); -ELEMENTS[8807] = Fluid3D([13772,14150,13674,13204],0); -ELEMENTS[8808] = Fluid3D([14432,13772,13674,13784],0); -ELEMENTS[8809] = Fluid3D([13510,13846,13176,13220],0); -ELEMENTS[8810] = Fluid3D([14151,13510,13176,13374],0); -ELEMENTS[8811] = Fluid3D([14151,13510,13374,14285],0); -ELEMENTS[8812] = Fluid3D([13510,13176,13374,12378],0); -ELEMENTS[8813] = Fluid3D([13176,14151,13374,13558],0); -ELEMENTS[8814] = Fluid3D([14150,14432,13674,14408],0); -ELEMENTS[8815] = Fluid3D([14150,14432,14408,14934],0); -ELEMENTS[8816] = Fluid3D([14432,14408,14934,15145],0); -ELEMENTS[8817] = Fluid3D([14432,14408,15145,14421],0); -ELEMENTS[8818] = Fluid3D([14432,14408,14421,13674],0); -ELEMENTS[8819] = Fluid3D([14408,14934,15145,15135],0); -ELEMENTS[8820] = Fluid3D([14934,15145,15135,15579],0); -ELEMENTS[8821] = Fluid3D([14934,15145,15579,15064],0); -ELEMENTS[8822] = Fluid3D([14408,14934,15135,14652],0); -ELEMENTS[8823] = Fluid3D([15145,14408,15135,14811],0); -ELEMENTS[8824] = Fluid3D([14934,15135,14652,15370],0); -ELEMENTS[8825] = Fluid3D([14934,15135,15370,15579],0); -ELEMENTS[8826] = Fluid3D([14408,14934,14652,14150],0); -ELEMENTS[8827] = Fluid3D([15145,14408,14811,14421],0); -ELEMENTS[8828] = Fluid3D([14150,14432,14934,14531],0); -ELEMENTS[8829] = Fluid3D([13674,14150,14408,13795],0); -ELEMENTS[8830] = Fluid3D([13674,14150,13795,13204],0); -ELEMENTS[8831] = Fluid3D([14150,14408,13795,14652],0); -ELEMENTS[8832] = Fluid3D([14408,13674,13795,13764],0); -ELEMENTS[8833] = Fluid3D([14408,13674,13764,14421],0); -ELEMENTS[8834] = Fluid3D([13795,14408,13764,14254],0); -ELEMENTS[8835] = Fluid3D([13795,14408,14254,14652],0); -ELEMENTS[8836] = Fluid3D([14408,13764,14254,14811],0); -ELEMENTS[8837] = Fluid3D([14934,14432,15145,15064],0); -ELEMENTS[8838] = Fluid3D([13674,13795,13764,13094],0); -ELEMENTS[8839] = Fluid3D([13674,13795,13094,13204],0); -ELEMENTS[8840] = Fluid3D([13764,13674,13094,13228],0); -ELEMENTS[8841] = Fluid3D([13795,13764,13094,13361],0); -ELEMENTS[8842] = Fluid3D([13674,13094,13228,12833],0); -ELEMENTS[8843] = Fluid3D([13674,13094,12833,13204],0); -ELEMENTS[8844] = Fluid3D([13795,13764,13361,14254],0); -ELEMENTS[8845] = Fluid3D([13764,13094,13361,12965],0); -ELEMENTS[8846] = Fluid3D([13094,13361,12965,12463],0); -ELEMENTS[8847] = Fluid3D([13094,13361,12463,12893],0); -ELEMENTS[8848] = Fluid3D([13094,13361,12893,13795],0); -ELEMENTS[8849] = Fluid3D([13361,13764,12965,13700],0); -ELEMENTS[8850] = Fluid3D([13361,13764,13700,14254],0); -ELEMENTS[8851] = Fluid3D([12965,13361,13700,12890],0); -ELEMENTS[8852] = Fluid3D([12965,13361,12890,12463],0); -ELEMENTS[8853] = Fluid3D([13361,13700,12890,13603],0); -ELEMENTS[8854] = Fluid3D([13361,13700,13603,14254],0); -ELEMENTS[8855] = Fluid3D([13764,13094,12965,13228],0); -ELEMENTS[8856] = Fluid3D([13700,12890,13603,13551],0); -ELEMENTS[8857] = Fluid3D([13603,13700,13551,14310],0); -ELEMENTS[8858] = Fluid3D([13603,13700,14310,14254],0); -ELEMENTS[8859] = Fluid3D([13700,12890,13551,13122],0); -ELEMENTS[8860] = Fluid3D([13700,12890,13122,12965],0); -ELEMENTS[8861] = Fluid3D([12890,13603,13551,13015],0); -ELEMENTS[8862] = Fluid3D([12890,13603,13015,12830],0); -ELEMENTS[8863] = Fluid3D([12890,13603,12830,13361],0); -ELEMENTS[8864] = Fluid3D([12890,13551,13122,12659],0); -ELEMENTS[8865] = Fluid3D([13551,12890,13015,12659],0); -ELEMENTS[8866] = Fluid3D([13551,13122,12659,13325],0); -ELEMENTS[8867] = Fluid3D([13551,13122,13325,13976],0); -ELEMENTS[8868] = Fluid3D([13551,13122,13976,13700],0); -ELEMENTS[8869] = Fluid3D([13122,12659,13325,12524],0); -ELEMENTS[8870] = Fluid3D([13122,12659,12524,12180],0); -ELEMENTS[8871] = Fluid3D([13122,12659,12180,12890],0); -ELEMENTS[8872] = Fluid3D([12659,13551,13325,13251],0); -ELEMENTS[8873] = Fluid3D([13551,13325,13251,14053],0); -ELEMENTS[8874] = Fluid3D([13551,13325,14053,13976],0); -ELEMENTS[8875] = Fluid3D([12659,13325,12524,12562],0); -ELEMENTS[8876] = Fluid3D([12524,12659,12562,11783],0); -ELEMENTS[8877] = Fluid3D([12524,12659,11783,12180],0); -ELEMENTS[8878] = Fluid3D([12659,13551,13251,13015],0); -ELEMENTS[8879] = Fluid3D([12659,13325,12562,13251],0); -ELEMENTS[8880] = Fluid3D([13764,13674,13228,14421],0); -ELEMENTS[8881] = Fluid3D([13094,13228,12833,12300],0); -ELEMENTS[8882] = Fluid3D([12833,13094,12300,12194],0); -ELEMENTS[8883] = Fluid3D([13094,13228,12300,12965],0); -ELEMENTS[8884] = Fluid3D([13228,12833,12300,12613],0); -ELEMENTS[8885] = Fluid3D([13228,12833,12613,13784],0); -ELEMENTS[8886] = Fluid3D([12300,13228,12613,12616],0); -ELEMENTS[8887] = Fluid3D([12300,13228,12616,12965],0); -ELEMENTS[8888] = Fluid3D([13228,12613,12616,13315],0); -ELEMENTS[8889] = Fluid3D([12613,12616,13315,12483],0); -ELEMENTS[8890] = Fluid3D([12613,12616,12483,11768],0); -ELEMENTS[8891] = Fluid3D([12613,12616,11768,12300],0); -ELEMENTS[8892] = Fluid3D([13228,12613,13315,13784],0); -ELEMENTS[8893] = Fluid3D([12616,13228,13315,13506],0); -ELEMENTS[8894] = Fluid3D([13315,12616,13506,13080],0); -ELEMENTS[8895] = Fluid3D([13315,12616,13080,12483],0); -ELEMENTS[8896] = Fluid3D([12616,13228,13506,12965],0); -ELEMENTS[8897] = Fluid3D([13228,13315,13506,14421],0); -ELEMENTS[8898] = Fluid3D([12833,12300,12613,11902],0); -ELEMENTS[8899] = Fluid3D([12833,12300,11902,12194],0); -ELEMENTS[8900] = Fluid3D([12613,12833,11902,12615],0); -ELEMENTS[8901] = Fluid3D([12613,12833,12615,13784],0); -ELEMENTS[8902] = Fluid3D([12300,12613,11902,11768],0); -ELEMENTS[8903] = Fluid3D([12833,11902,12615,12305],0); -ELEMENTS[8904] = Fluid3D([12833,11902,12305,12194],0); -ELEMENTS[8905] = Fluid3D([12615,12833,12305,13237],0); -ELEMENTS[8906] = Fluid3D([12615,12833,13237,13784],0); -ELEMENTS[8907] = Fluid3D([12833,12305,13237,13204],0); -ELEMENTS[8908] = Fluid3D([11902,12615,12305,11848],0); -ELEMENTS[8909] = Fluid3D([12305,11902,11848,11219],0); -ELEMENTS[8910] = Fluid3D([11848,12305,11219,12504],0); -ELEMENTS[8911] = Fluid3D([11848,12305,12504,12615],0); -ELEMENTS[8912] = Fluid3D([12305,11219,12504,12019],0); -ELEMENTS[8913] = Fluid3D([12504,12305,12019,13176],0); -ELEMENTS[8914] = Fluid3D([12305,11219,12019,11301],0); -ELEMENTS[8915] = Fluid3D([12504,12305,13176,13237],0); -ELEMENTS[8916] = Fluid3D([12504,12305,13237,12615],0); -ELEMENTS[8917] = Fluid3D([13176,12504,13237,13558],0); -ELEMENTS[8918] = Fluid3D([13237,13176,13558,13772],0); -ELEMENTS[8919] = Fluid3D([13558,13237,13772,13784],0); -ELEMENTS[8920] = Fluid3D([13237,13176,13772,13204],0); -ELEMENTS[8921] = Fluid3D([13237,13772,13784,13674],0); -ELEMENTS[8922] = Fluid3D([13558,13237,13784,12615],0); -ELEMENTS[8923] = Fluid3D([13772,13237,13204,13674],0); -ELEMENTS[8924] = Fluid3D([13237,13176,13204,12305],0); -ELEMENTS[8925] = Fluid3D([13558,13237,12615,12504],0); -ELEMENTS[8926] = Fluid3D([11902,12615,11848,11861],0); -ELEMENTS[8927] = Fluid3D([11902,12615,11861,12613],0); -ELEMENTS[8928] = Fluid3D([12019,12305,11301,12194],0); -ELEMENTS[8929] = Fluid3D([13700,13551,14310,13976],0); -ELEMENTS[8930] = Fluid3D([13315,12613,12483,13014],0); -ELEMENTS[8931] = Fluid3D([13315,12613,13014,13784],0); -ELEMENTS[8932] = Fluid3D([12613,12483,13014,11861],0); -ELEMENTS[8933] = Fluid3D([12483,13315,13014,13250],0); -ELEMENTS[8934] = Fluid3D([13014,12483,13250,12518],0); -ELEMENTS[8935] = Fluid3D([13014,12483,12518,11861],0); -ELEMENTS[8936] = Fluid3D([13250,13014,12518,13384],0); -ELEMENTS[8937] = Fluid3D([13250,13014,13384,13888],0); -ELEMENTS[8938] = Fluid3D([13250,13014,13888,13315],0); -ELEMENTS[8939] = Fluid3D([13014,12518,13384,12683],0); -ELEMENTS[8940] = Fluid3D([13014,12518,12683,11861],0); -ELEMENTS[8941] = Fluid3D([12518,13384,12683,12731],0); -ELEMENTS[8942] = Fluid3D([12483,13315,13250,13080],0); -ELEMENTS[8943] = Fluid3D([12518,13384,12731,13089],0); -ELEMENTS[8944] = Fluid3D([12518,13384,13089,13250],0); -ELEMENTS[8945] = Fluid3D([13384,12683,12731,13331],0); -ELEMENTS[8946] = Fluid3D([12683,12731,13331,12450],0); -ELEMENTS[8947] = Fluid3D([12683,12731,12450,11852],0); -ELEMENTS[8948] = Fluid3D([13384,12683,13331,13556],0); -ELEMENTS[8949] = Fluid3D([13384,12683,13556,13014],0); -ELEMENTS[8950] = Fluid3D([13384,12731,13089,13607],0); -ELEMENTS[8951] = Fluid3D([12731,13089,13607,12920],0); -ELEMENTS[8952] = Fluid3D([13384,12731,13607,13331],0); -ELEMENTS[8953] = Fluid3D([12683,12731,11852,12518],0); -ELEMENTS[8954] = Fluid3D([12731,13089,12920,12179],0); -ELEMENTS[8955] = Fluid3D([12920,12731,12179,12118],0); -ELEMENTS[8956] = Fluid3D([12920,12731,12118,13000],0); -ELEMENTS[8957] = Fluid3D([12731,13089,12179,12518],0); -ELEMENTS[8958] = Fluid3D([13089,12920,12179,12847],0); -ELEMENTS[8959] = Fluid3D([12920,12731,13000,13607],0); -ELEMENTS[8960] = Fluid3D([12616,13506,13080,12817],0); -ELEMENTS[8961] = Fluid3D([12616,13506,12817,12965],0); -ELEMENTS[8962] = Fluid3D([13080,12616,12817,12152],0); -ELEMENTS[8963] = Fluid3D([13080,12616,12152,12483],0); -ELEMENTS[8964] = Fluid3D([12616,12817,12152,11964],0); -ELEMENTS[8965] = Fluid3D([12616,12817,11964,12965],0); -ELEMENTS[8966] = Fluid3D([13506,13080,12817,13641],0); -ELEMENTS[8967] = Fluid3D([13080,12817,13641,12878],0); -ELEMENTS[8968] = Fluid3D([13080,12817,12878,12152],0); -ELEMENTS[8969] = Fluid3D([12817,12152,11964,12020],0); -ELEMENTS[8970] = Fluid3D([12817,12152,12020,12878],0); -ELEMENTS[8971] = Fluid3D([12152,11964,12020,11236],0); -ELEMENTS[8972] = Fluid3D([11964,12020,11236,11326],0); -ELEMENTS[8973] = Fluid3D([13506,13080,13641,13967],0); -ELEMENTS[8974] = Fluid3D([12152,11964,11236,11768],0); -ELEMENTS[8975] = Fluid3D([11964,12020,11326,12180],0); -ELEMENTS[8976] = Fluid3D([13506,13080,13967,13315],0); -ELEMENTS[8977] = Fluid3D([11326,11964,12180,11385],0); -ELEMENTS[8978] = Fluid3D([11964,12180,11385,12965],0); -ELEMENTS[8979] = Fluid3D([11326,11964,11385,11236],0); -ELEMENTS[8980] = Fluid3D([12152,12616,11964,11768],0); -ELEMENTS[8981] = Fluid3D([13014,13384,13888,13556],0); -ELEMENTS[8982] = Fluid3D([12483,13250,12518,12514],0); -ELEMENTS[8983] = Fluid3D([12518,12483,12514,11698],0); -ELEMENTS[8984] = Fluid3D([12483,13250,12514,13080],0); -ELEMENTS[8985] = Fluid3D([12514,12518,11698,12179],0); -ELEMENTS[8986] = Fluid3D([13250,12518,12514,13089],0); -ELEMENTS[8987] = Fluid3D([12518,12483,11698,11861],0); -ELEMENTS[8988] = Fluid3D([12483,12514,11698,12152],0); -ELEMENTS[8989] = Fluid3D([13089,13384,13607,14117],0); -ELEMENTS[8990] = Fluid3D([13089,13384,14117,13250],0); -ELEMENTS[8991] = Fluid3D([13384,13607,14117,14198],0); -ELEMENTS[8992] = Fluid3D([13384,13607,14198,13331],0); -ELEMENTS[8993] = Fluid3D([14117,13384,14198,13888],0); -ELEMENTS[8994] = Fluid3D([13607,13089,14117,13745],0); -ELEMENTS[8995] = Fluid3D([13607,13089,13745,12920],0); -ELEMENTS[8996] = Fluid3D([13089,14117,13745,13629],0); -ELEMENTS[8997] = Fluid3D([14117,13607,13745,14396],0); -ELEMENTS[8998] = Fluid3D([13745,14117,14396,14453],0); -ELEMENTS[8999] = Fluid3D([14117,13745,13629,14453],0); -ELEMENTS[9000] = Fluid3D([14117,13607,14396,14198],0); -ELEMENTS[9001] = Fluid3D([13745,13089,13629,12847],0); -ELEMENTS[9002] = Fluid3D([13089,14117,13629,13250],0); -ELEMENTS[9003] = Fluid3D([14208,13339,13510,13527],0); -ELEMENTS[9004] = Fluid3D([13339,13510,13527,12942],0); -ELEMENTS[9005] = Fluid3D([13339,13510,12942,12717],0); -ELEMENTS[9006] = Fluid3D([13527,13339,12942,12802],0); -ELEMENTS[9007] = Fluid3D([13339,12942,12802,12187],0); -ELEMENTS[9008] = Fluid3D([13510,13527,12942,12378],0); -ELEMENTS[9009] = Fluid3D([12942,13527,12802,12378],0); -ELEMENTS[9010] = Fluid3D([13527,13339,12802,13596],0); -ELEMENTS[9011] = Fluid3D([13510,14208,13527,14285],0); -ELEMENTS[9012] = Fluid3D([14208,13339,13527,13596],0); -ELEMENTS[9013] = Fluid3D([13846,13772,13204,14150],0); -ELEMENTS[9014] = Fluid3D([12713,12530,12700,11853],0); -ELEMENTS[9015] = Fluid3D([12700,12713,11853,12278],0); -ELEMENTS[9016] = Fluid3D([12713,12530,11853,11913],0); -ELEMENTS[9017] = Fluid3D([11853,12713,11913,12278],0); -ELEMENTS[9018] = Fluid3D([12713,11913,12278,12295],0); -ELEMENTS[9019] = Fluid3D([12530,12700,11853,12146],0); -ELEMENTS[9020] = Fluid3D([12700,11853,12146,12241],0); -ELEMENTS[9021] = Fluid3D([11853,12530,12146,11637],0); -ELEMENTS[9022] = Fluid3D([11853,12530,11637,11913],0); -ELEMENTS[9023] = Fluid3D([12146,11853,11637,11028],0); -ELEMENTS[9024] = Fluid3D([12530,12146,11637,12607],0); -ELEMENTS[9025] = Fluid3D([11853,11637,11028,11042],0); -ELEMENTS[9026] = Fluid3D([12530,12146,12607,12700],0); -ELEMENTS[9027] = Fluid3D([11637,12530,12607,11774],0); -ELEMENTS[9028] = Fluid3D([12146,11637,12607,11480],0); -ELEMENTS[9029] = Fluid3D([12607,12146,11480,12142],0); -ELEMENTS[9030] = Fluid3D([12607,12146,12142,12971],0); -ELEMENTS[9031] = Fluid3D([12607,12146,12971,13221],0); -ELEMENTS[9032] = Fluid3D([12971,12607,13221,13121],0); -ELEMENTS[9033] = Fluid3D([13221,12971,13121,13639],0); -ELEMENTS[9034] = Fluid3D([12971,13121,13639,13328],0); -ELEMENTS[9035] = Fluid3D([13121,13221,13639,13708],0); -ELEMENTS[9036] = Fluid3D([13639,13121,13708,13413],0); -ELEMENTS[9037] = Fluid3D([13639,13121,13413,13070],0); -ELEMENTS[9038] = Fluid3D([13639,13121,13070,13328],0); -ELEMENTS[9039] = Fluid3D([13121,13413,13070,12533],0); -ELEMENTS[9040] = Fluid3D([13121,13413,12533,13225],0); -ELEMENTS[9041] = Fluid3D([12146,12971,13221,12700],0); -ELEMENTS[9042] = Fluid3D([12146,11637,11480,11028],0); -ELEMENTS[9043] = Fluid3D([13221,12971,13639,13328],0); -ELEMENTS[9044] = Fluid3D([13070,13121,12533,12142],0); -ELEMENTS[9045] = Fluid3D([12146,11480,12142,11058],0); -ELEMENTS[9046] = Fluid3D([13121,13708,13413,13225],0); -ELEMENTS[9047] = Fluid3D([13221,12971,13328,12945],0); -ELEMENTS[9048] = Fluid3D([12971,13328,12945,12729],0); -ELEMENTS[9049] = Fluid3D([12146,12142,12971,12223],0); -ELEMENTS[9050] = Fluid3D([11637,11853,11913,11042],0); -ELEMENTS[9051] = Fluid3D([12146,12142,12223,11058],0); -ELEMENTS[9052] = Fluid3D([12971,12607,13121,12142],0); -ELEMENTS[9053] = Fluid3D([12971,12146,12223,12945],0); -ELEMENTS[9054] = Fluid3D([12223,12971,12945,12729],0); -ELEMENTS[9055] = Fluid3D([12945,12223,12729,12241],0); -ELEMENTS[9056] = Fluid3D([13221,12971,12945,12700],0); -ELEMENTS[9057] = Fluid3D([12607,12146,13221,12700],0); -ELEMENTS[9058] = Fluid3D([12607,13221,13121,13708],0); -ELEMENTS[9059] = Fluid3D([11480,12607,12142,11843],0); -ELEMENTS[9060] = Fluid3D([13413,13070,12533,12849],0); -ELEMENTS[9061] = Fluid3D([12533,13413,12849,12720],0); -ELEMENTS[9062] = Fluid3D([12533,13413,12720,13225],0); -ELEMENTS[9063] = Fluid3D([11637,12530,11774,11790],0); -ELEMENTS[9064] = Fluid3D([12849,12533,12720,11423],0); -ELEMENTS[9065] = Fluid3D([13070,12533,12849,12216],0); -ELEMENTS[9066] = Fluid3D([12533,12849,12216,11423],0); -ELEMENTS[9067] = Fluid3D([13070,12533,12216,12142],0); -ELEMENTS[9068] = Fluid3D([12533,12216,12142,11843],0); -ELEMENTS[9069] = Fluid3D([12142,12533,11843,12607],0); -ELEMENTS[9070] = Fluid3D([12533,11843,12607,12507],0); -ELEMENTS[9071] = Fluid3D([12533,11843,12507,12057],0); -ELEMENTS[9072] = Fluid3D([12142,12533,12607,13121],0); -ELEMENTS[9073] = Fluid3D([12533,12607,13121,12507],0); -ELEMENTS[9074] = Fluid3D([12216,13070,12142,12401],0); -ELEMENTS[9075] = Fluid3D([12142,12216,12401,11403],0); -ELEMENTS[9076] = Fluid3D([12142,12216,11403,11843],0); -ELEMENTS[9077] = Fluid3D([12216,13070,12401,12830],0); -ELEMENTS[9078] = Fluid3D([12401,12216,12830,11886],0); -ELEMENTS[9079] = Fluid3D([12830,12401,11886,12463],0); -ELEMENTS[9080] = Fluid3D([12401,12216,11886,11403],0); -ELEMENTS[9081] = Fluid3D([12216,11886,11403,11895],0); -ELEMENTS[9082] = Fluid3D([11886,11403,11895,10876],0); -ELEMENTS[9083] = Fluid3D([11403,12216,11895,11423],0); -ELEMENTS[9084] = Fluid3D([11886,11403,10876,11072],0); -ELEMENTS[9085] = Fluid3D([11886,11403,11072,12401],0); -ELEMENTS[9086] = Fluid3D([11895,11403,11423,10720],0); -ELEMENTS[9087] = Fluid3D([12216,11886,11895,12830],0); -ELEMENTS[9088] = Fluid3D([12142,12971,12223,12401],0); -ELEMENTS[9089] = Fluid3D([13413,12849,12720,13427],0); -ELEMENTS[9090] = Fluid3D([12720,13413,13427,13225],0); -ELEMENTS[9091] = Fluid3D([13427,12720,13225,12927],0); -ELEMENTS[9092] = Fluid3D([13427,12720,12927,12714],0); -ELEMENTS[9093] = Fluid3D([12849,13070,12216,12830],0); -ELEMENTS[9094] = Fluid3D([13413,13070,12849,13701],0); -ELEMENTS[9095] = Fluid3D([12849,13413,13701,14049],0); -ELEMENTS[9096] = Fluid3D([13413,13701,14049,14263],0); -ELEMENTS[9097] = Fluid3D([13070,12849,13701,12830],0); -ELEMENTS[9098] = Fluid3D([12223,12142,12401,11766],0); -ELEMENTS[9099] = Fluid3D([12223,12142,11766,11058],0); -ELEMENTS[9100] = Fluid3D([12142,11766,11058,11403],0); -ELEMENTS[9101] = Fluid3D([11766,11058,11403,11072],0); -ELEMENTS[9102] = Fluid3D([11766,11058,11072,10912],0); -ELEMENTS[9103] = Fluid3D([11403,11766,11072,12401],0); -ELEMENTS[9104] = Fluid3D([12142,12401,11766,11403],0); -ELEMENTS[9105] = Fluid3D([13413,13070,13701,13639],0); -ELEMENTS[9106] = Fluid3D([14094,14656,14158,14594],0); -ELEMENTS[9107] = Fluid3D([11834,11899,11847,10552],0); -ELEMENTS[9108] = Fluid3D([12432,11899,11448,11475],0); -ELEMENTS[9109] = Fluid3D([10305,10217,11012,10087],0); -ELEMENTS[9110] = Fluid3D([11055,11377,11059,12222],0); -ELEMENTS[9111] = Fluid3D([11048,11119,11560,11986],0); -ELEMENTS[9112] = Fluid3D([10071,10217,10268,11119],0); -ELEMENTS[9113] = Fluid3D([9476,10071,10268,9552],0); -ELEMENTS[9114] = Fluid3D([9762,10016,10724,10492],0); -ELEMENTS[9115] = Fluid3D([12718,12622,13066,13572],0); -ELEMENTS[9116] = Fluid3D([13066,12718,13572,13471],0); -ELEMENTS[9117] = Fluid3D([12718,12622,13572,12939],0); -ELEMENTS[9118] = Fluid3D([12718,12622,12939,11982],0); -ELEMENTS[9119] = Fluid3D([13572,12718,12939,13768],0); -ELEMENTS[9120] = Fluid3D([12622,13066,13572,13285],0); -ELEMENTS[9121] = Fluid3D([13066,13572,13285,13800],0); -ELEMENTS[9122] = Fluid3D([13285,13066,13800,13265],0); -ELEMENTS[9123] = Fluid3D([12622,13066,13285,12390],0); -ELEMENTS[9124] = Fluid3D([13800,13285,13265,14043],0); -ELEMENTS[9125] = Fluid3D([12622,13066,12390,11992],0); -ELEMENTS[9126] = Fluid3D([13800,13285,14043,14082],0); -ELEMENTS[9127] = Fluid3D([13285,14043,14082,13799],0); -ELEMENTS[9128] = Fluid3D([13285,14043,13799,13196],0); -ELEMENTS[9129] = Fluid3D([13285,14043,13196,13265],0); -ELEMENTS[9130] = Fluid3D([14082,13285,13799,13411],0); -ELEMENTS[9131] = Fluid3D([13799,14082,13411,14337],0); -ELEMENTS[9132] = Fluid3D([13799,14082,14337,14775],0); -ELEMENTS[9133] = Fluid3D([13799,14082,14775,14043],0); -ELEMENTS[9134] = Fluid3D([14082,13285,13411,13572],0); -ELEMENTS[9135] = Fluid3D([13800,13285,14082,13572],0); -ELEMENTS[9136] = Fluid3D([13285,13066,13265,12390],0); -ELEMENTS[9137] = Fluid3D([13572,12622,13285,13411],0); -ELEMENTS[9138] = Fluid3D([13285,13799,13411,12933],0); -ELEMENTS[9139] = Fluid3D([13799,13411,12933,13582],0); -ELEMENTS[9140] = Fluid3D([13411,12933,13582,12910],0); -ELEMENTS[9141] = Fluid3D([13582,13411,12910,13770],0); -ELEMENTS[9142] = Fluid3D([13582,13411,13770,14337],0); -ELEMENTS[9143] = Fluid3D([13411,12933,12910,12622],0); -ELEMENTS[9144] = Fluid3D([13285,13799,12933,13196],0); -ELEMENTS[9145] = Fluid3D([13799,13411,13582,14337],0); -ELEMENTS[9146] = Fluid3D([12933,13799,13582,13320],0); -ELEMENTS[9147] = Fluid3D([13799,13582,13320,13863],0); -ELEMENTS[9148] = Fluid3D([13582,13320,13863,13123],0); -ELEMENTS[9149] = Fluid3D([13582,12933,13320,13123],0); -ELEMENTS[9150] = Fluid3D([12933,13799,13320,13196],0); -ELEMENTS[9151] = Fluid3D([13411,13285,12933,12622],0); -ELEMENTS[9152] = Fluid3D([12622,13572,12939,13411],0); -ELEMENTS[9153] = Fluid3D([13411,12910,13770,13434],0); -ELEMENTS[9154] = Fluid3D([12933,13582,12910,13123],0); -ELEMENTS[9155] = Fluid3D([13066,13572,13800,13594],0); -ELEMENTS[9156] = Fluid3D([13066,13572,13594,13471],0); -ELEMENTS[9157] = Fluid3D([13800,13066,13594,13304],0); -ELEMENTS[9158] = Fluid3D([13572,13800,13594,14298],0); -ELEMENTS[9159] = Fluid3D([13594,13572,14298,13471],0); -ELEMENTS[9160] = Fluid3D([13594,13800,13304,14182],0); -ELEMENTS[9161] = Fluid3D([13594,13800,14182,14298],0); -ELEMENTS[9162] = Fluid3D([14298,13594,13471,14182],0); -ELEMENTS[9163] = Fluid3D([13594,13471,14182,13304],0); -ELEMENTS[9164] = Fluid3D([13800,13066,13304,13265],0); -ELEMENTS[9165] = Fluid3D([13572,13800,14298,14082],0); -ELEMENTS[9166] = Fluid3D([13066,13594,13304,13471],0); -ELEMENTS[9167] = Fluid3D([13800,13304,14182,14136],0); -ELEMENTS[9168] = Fluid3D([13800,13304,14136,13265],0); -ELEMENTS[9169] = Fluid3D([13304,14182,14136,13948],0); -ELEMENTS[9170] = Fluid3D([14182,13800,14136,14621],0); -ELEMENTS[9171] = Fluid3D([13800,14136,14621,14043],0); -ELEMENTS[9172] = Fluid3D([14182,13800,14621,14298],0); -ELEMENTS[9173] = Fluid3D([14182,14136,13948,14891],0); -ELEMENTS[9174] = Fluid3D([13948,14182,14891,14741],0); -ELEMENTS[9175] = Fluid3D([14136,13948,14891,13623],0); -ELEMENTS[9176] = Fluid3D([14182,14136,14891,14621],0); -ELEMENTS[9177] = Fluid3D([13304,14182,13948,13669],0); -ELEMENTS[9178] = Fluid3D([13304,14182,13669,13471],0); -ELEMENTS[9179] = Fluid3D([13948,13304,13669,13146],0); -ELEMENTS[9180] = Fluid3D([14182,13948,13669,14741],0); -ELEMENTS[9181] = Fluid3D([14136,13304,13948,13623],0); -ELEMENTS[9182] = Fluid3D([14043,13800,14082,14621],0); -ELEMENTS[9183] = Fluid3D([13265,13800,14043,14136],0); -ELEMENTS[9184] = Fluid3D([12910,13582,13770,13294],0); -ELEMENTS[9185] = Fluid3D([13582,13770,13294,14164],0); -ELEMENTS[9186] = Fluid3D([13770,13294,14164,13887],0); -ELEMENTS[9187] = Fluid3D([13294,14164,13887,13670],0); -ELEMENTS[9188] = Fluid3D([12910,13582,13294,13123],0); -ELEMENTS[9189] = Fluid3D([13582,13294,13123,14164],0); -ELEMENTS[9190] = Fluid3D([13770,12910,13294,13071],0); -ELEMENTS[9191] = Fluid3D([13294,13770,13071,13887],0); -ELEMENTS[9192] = Fluid3D([12910,13294,13071,12389],0); -ELEMENTS[9193] = Fluid3D([13071,12910,12389,12408],0); -ELEMENTS[9194] = Fluid3D([12389,13071,12408,12427],0); -ELEMENTS[9195] = Fluid3D([13770,12910,13071,13434],0); -ELEMENTS[9196] = Fluid3D([13071,12910,12408,13434],0); -ELEMENTS[9197] = Fluid3D([12910,13294,12389,13123],0); -ELEMENTS[9198] = Fluid3D([13582,13770,14164,14337],0); -ELEMENTS[9199] = Fluid3D([14164,13770,13887,14555],0); -ELEMENTS[9200] = Fluid3D([14164,13770,14555,14337],0); -ELEMENTS[9201] = Fluid3D([13770,13887,14555,14210],0); -ELEMENTS[9202] = Fluid3D([13887,14164,14555,14649],0); -ELEMENTS[9203] = Fluid3D([14164,14555,14649,14849],0); -ELEMENTS[9204] = Fluid3D([13887,14164,14649,13670],0); -ELEMENTS[9205] = Fluid3D([14555,13887,14649,14591],0); -ELEMENTS[9206] = Fluid3D([14649,14555,14591,15214],0); -ELEMENTS[9207] = Fluid3D([14555,13887,14591,14111],0); -ELEMENTS[9208] = Fluid3D([13887,14591,14111,13986],0); -ELEMENTS[9209] = Fluid3D([14111,13887,13986,13224],0); -ELEMENTS[9210] = Fluid3D([14111,13887,13224,13071],0); -ELEMENTS[9211] = Fluid3D([14591,14111,13986,14068],0); -ELEMENTS[9212] = Fluid3D([13986,14111,13224,13270],0); -ELEMENTS[9213] = Fluid3D([13887,13224,13071,12957],0); -ELEMENTS[9214] = Fluid3D([13224,14111,13071,13170],0); -ELEMENTS[9215] = Fluid3D([13071,13224,13170,12427],0); -ELEMENTS[9216] = Fluid3D([14111,13071,13170,14210],0); -ELEMENTS[9217] = Fluid3D([13887,13986,13224,13709],0); -ELEMENTS[9218] = Fluid3D([13887,13986,13709,14649],0); -ELEMENTS[9219] = Fluid3D([13224,13887,13709,12957],0); -ELEMENTS[9220] = Fluid3D([13986,13224,13709,12772],0); -ELEMENTS[9221] = Fluid3D([13709,13887,14649,13670],0); -ELEMENTS[9222] = Fluid3D([14555,13887,14111,14210],0); -ELEMENTS[9223] = Fluid3D([14111,13224,13270,13170],0); -ELEMENTS[9224] = Fluid3D([13887,14591,13986,14649],0); -ELEMENTS[9225] = Fluid3D([14111,13887,13071,14210],0); -ELEMENTS[9226] = Fluid3D([13170,13071,12427,12408],0); -ELEMENTS[9227] = Fluid3D([13887,13709,12957,13670],0); -ELEMENTS[9228] = Fluid3D([13224,13270,13170,12427],0); -ELEMENTS[9229] = Fluid3D([14555,14591,15214,14648],0); -ELEMENTS[9230] = Fluid3D([13224,13709,12772,12957],0); -ELEMENTS[9231] = Fluid3D([14649,14555,15214,15353],0); -ELEMENTS[9232] = Fluid3D([15214,14649,15353,15169],0); -ELEMENTS[9233] = Fluid3D([14649,15353,15169,14970],0); -ELEMENTS[9234] = Fluid3D([15169,14649,14970,14476],0); -ELEMENTS[9235] = Fluid3D([15353,15214,15169,15904],0); -ELEMENTS[9236] = Fluid3D([14649,15353,14970,14849],0); -ELEMENTS[9237] = Fluid3D([14591,14649,15214,15169],0); -ELEMENTS[9238] = Fluid3D([13294,13071,12389,12957],0); -ELEMENTS[9239] = Fluid3D([12389,13294,12957,13123],0); -ELEMENTS[9240] = Fluid3D([13294,12957,13123,13670],0); -ELEMENTS[9241] = Fluid3D([13294,12957,13670,13887],0); -ELEMENTS[9242] = Fluid3D([13294,13071,12957,13887],0); -ELEMENTS[9243] = Fluid3D([13123,13294,13670,14164],0); -ELEMENTS[9244] = Fluid3D([12910,12389,12408,11782],0); -ELEMENTS[9245] = Fluid3D([14337,13799,14775,14564],0); -ELEMENTS[9246] = Fluid3D([13285,12622,12390,12933],0); -ELEMENTS[9247] = Fluid3D([13641,13506,13967,14454],0); -ELEMENTS[9248] = Fluid3D([13641,13506,14454,13656],0); -ELEMENTS[9249] = Fluid3D([13967,13641,14454,14420],0); -ELEMENTS[9250] = Fluid3D([13967,13641,14420,13753],0); -ELEMENTS[9251] = Fluid3D([14420,13967,13753,14446],0); -ELEMENTS[9252] = Fluid3D([13506,14454,13656,13997],0); -ELEMENTS[9253] = Fluid3D([13641,14454,14420,14176],0); -ELEMENTS[9254] = Fluid3D([13506,14454,13997,14421],0); -ELEMENTS[9255] = Fluid3D([13641,14454,14176,13656],0); -ELEMENTS[9256] = Fluid3D([13967,13641,13753,13080],0); -ELEMENTS[9257] = Fluid3D([13656,13506,13997,12965],0); -ELEMENTS[9258] = Fluid3D([14420,13967,14446,14804],0); -ELEMENTS[9259] = Fluid3D([14420,13967,14804,14454],0); -ELEMENTS[9260] = Fluid3D([13967,14446,14804,14401],0); -ELEMENTS[9261] = Fluid3D([14804,13967,14401,14354],0); -ELEMENTS[9262] = Fluid3D([14804,13967,14354,14454],0); -ELEMENTS[9263] = Fluid3D([13967,14446,14401,13250],0); -ELEMENTS[9264] = Fluid3D([14401,14804,14354,15033],0); -ELEMENTS[9265] = Fluid3D([14804,14354,15033,15016],0); -ELEMENTS[9266] = Fluid3D([14401,14804,15033,15121],0); -ELEMENTS[9267] = Fluid3D([14804,15033,15121,15438],0); -ELEMENTS[9268] = Fluid3D([14804,15033,15438,15016],0); -ELEMENTS[9269] = Fluid3D([14401,14804,15121,14446],0); -ELEMENTS[9270] = Fluid3D([14354,14401,15033,14413],0); -ELEMENTS[9271] = Fluid3D([14354,14401,14413,13888],0); -ELEMENTS[9272] = Fluid3D([14401,14413,13888,14574],0); -ELEMENTS[9273] = Fluid3D([14413,13888,14574,14114],0); -ELEMENTS[9274] = Fluid3D([14413,13888,14114,13784],0); -ELEMENTS[9275] = Fluid3D([13888,14401,14574,14117],0); -ELEMENTS[9276] = Fluid3D([13888,14574,14114,14198],0); -ELEMENTS[9277] = Fluid3D([14574,14413,14114,14917],0); -ELEMENTS[9278] = Fluid3D([14413,14114,14917,14407],0); -ELEMENTS[9279] = Fluid3D([14413,14114,14407,13784],0); -ELEMENTS[9280] = Fluid3D([14574,14413,14917,15033],0); -ELEMENTS[9281] = Fluid3D([14401,14413,14574,15033],0); -ELEMENTS[9282] = Fluid3D([14917,14413,14407,15021],0); -ELEMENTS[9283] = Fluid3D([14917,14413,15021,15033],0); -ELEMENTS[9284] = Fluid3D([14413,14407,15021,14432],0); -ELEMENTS[9285] = Fluid3D([14114,14917,14407,14545],0); -ELEMENTS[9286] = Fluid3D([14407,14114,14545,13777],0); -ELEMENTS[9287] = Fluid3D([14114,14574,14917,14537],0); -ELEMENTS[9288] = Fluid3D([14574,14917,14537,15263],0); -ELEMENTS[9289] = Fluid3D([14407,14917,15021,15140],0); -ELEMENTS[9290] = Fluid3D([14917,15021,15140,15565],0); -ELEMENTS[9291] = Fluid3D([14917,15021,15565,15033],0); -ELEMENTS[9292] = Fluid3D([14917,14537,15263,15297],0); -ELEMENTS[9293] = Fluid3D([14917,14537,15297,14545],0); -ELEMENTS[9294] = Fluid3D([14545,14407,13777,14359],0); -ELEMENTS[9295] = Fluid3D([14407,13777,14359,13784],0); -ELEMENTS[9296] = Fluid3D([14359,14407,13784,14432],0); -ELEMENTS[9297] = Fluid3D([14359,14407,14432,15064],0); -ELEMENTS[9298] = Fluid3D([14359,14407,15064,15140],0); -ELEMENTS[9299] = Fluid3D([14359,14407,15140,14545],0); -ELEMENTS[9300] = Fluid3D([14407,13777,13784,14114],0); -ELEMENTS[9301] = Fluid3D([14574,14917,15263,15033],0); -ELEMENTS[9302] = Fluid3D([14114,14917,14545,14537],0); -ELEMENTS[9303] = Fluid3D([14114,14545,13777,13878],0); -ELEMENTS[9304] = Fluid3D([14114,14545,13878,14537],0); -ELEMENTS[9305] = Fluid3D([13777,14114,13878,13556],0); -ELEMENTS[9306] = Fluid3D([14114,13878,13556,14198],0); -ELEMENTS[9307] = Fluid3D([13777,14114,13556,13784],0); -ELEMENTS[9308] = Fluid3D([13878,13777,13556,13072],0); -ELEMENTS[9309] = Fluid3D([13556,13878,13072,13331],0); -ELEMENTS[9310] = Fluid3D([13556,13878,13331,14198],0); -ELEMENTS[9311] = Fluid3D([13777,13556,13072,12995],0); -ELEMENTS[9312] = Fluid3D([13556,13072,12995,12683],0); -ELEMENTS[9313] = Fluid3D([13878,13777,13072,13704],0); -ELEMENTS[9314] = Fluid3D([13072,13878,13704,13375],0); -ELEMENTS[9315] = Fluid3D([13072,13878,13375,13331],0); -ELEMENTS[9316] = Fluid3D([13878,13704,13375,14108],0); -ELEMENTS[9317] = Fluid3D([13375,13878,14108,14079],0); -ELEMENTS[9318] = Fluid3D([13704,13072,13375,12660],0); -ELEMENTS[9319] = Fluid3D([13072,13375,12660,12469],0); -ELEMENTS[9320] = Fluid3D([13878,14108,14079,14537],0); -ELEMENTS[9321] = Fluid3D([13777,13556,12995,13784],0); -ELEMENTS[9322] = Fluid3D([13072,13375,12469,13331],0); -ELEMENTS[9323] = Fluid3D([13704,13072,12660,12979],0); -ELEMENTS[9324] = Fluid3D([13704,13072,12979,13777],0); -ELEMENTS[9325] = Fluid3D([13072,12660,12979,12237],0); -ELEMENTS[9326] = Fluid3D([13072,12660,12237,12469],0); -ELEMENTS[9327] = Fluid3D([12979,13072,12237,12995],0); -ELEMENTS[9328] = Fluid3D([13375,13878,14079,13331],0); -ELEMENTS[9329] = Fluid3D([13375,12660,12469,12738],0); -ELEMENTS[9330] = Fluid3D([12469,13375,12738,12894],0); -ELEMENTS[9331] = Fluid3D([12469,13375,12894,13331],0); -ELEMENTS[9332] = Fluid3D([13878,13777,13704,14545],0); -ELEMENTS[9333] = Fluid3D([13878,13704,14108,14545],0); -ELEMENTS[9334] = Fluid3D([14108,13375,14079,13858],0); -ELEMENTS[9335] = Fluid3D([13375,14079,13858,12894],0); -ELEMENTS[9336] = Fluid3D([14114,14574,14537,14198],0); -ELEMENTS[9337] = Fluid3D([14574,14537,14198,14945],0); -ELEMENTS[9338] = Fluid3D([14198,14574,14945,14117],0); -ELEMENTS[9339] = Fluid3D([14537,14198,14945,14550],0); -ELEMENTS[9340] = Fluid3D([14537,14198,14550,14079],0); -ELEMENTS[9341] = Fluid3D([14198,14945,14550,14396],0); -ELEMENTS[9342] = Fluid3D([14574,14537,14945,15263],0); -ELEMENTS[9343] = Fluid3D([14945,14574,15263,15167],0); -ELEMENTS[9344] = Fluid3D([15263,14945,15167,15591],0); -ELEMENTS[9345] = Fluid3D([15263,14945,15591,15393],0); -ELEMENTS[9346] = Fluid3D([15263,14945,15393,14537],0); -ELEMENTS[9347] = Fluid3D([14945,15591,15393,15255],0); -ELEMENTS[9348] = Fluid3D([15591,15263,15393,15879],0); -ELEMENTS[9349] = Fluid3D([14945,15167,15591,15109],0); -ELEMENTS[9350] = Fluid3D([15167,15263,15591,15757],0); -ELEMENTS[9351] = Fluid3D([14945,15591,15255,15109],0); -ELEMENTS[9352] = Fluid3D([15591,15263,15879,15757],0); -ELEMENTS[9353] = Fluid3D([14945,15167,15109,14117],0); -ELEMENTS[9354] = Fluid3D([15393,14945,15255,14550],0); -ELEMENTS[9355] = Fluid3D([15263,15393,15879,15297],0); -ELEMENTS[9356] = Fluid3D([15167,15263,15757,15033],0); -ELEMENTS[9357] = Fluid3D([14945,14574,15167,14117],0); -ELEMENTS[9358] = Fluid3D([15255,14945,15109,14396],0); -ELEMENTS[9359] = Fluid3D([15263,15879,15757,15565],0); -ELEMENTS[9360] = Fluid3D([14574,15263,15167,15033],0); -ELEMENTS[9361] = Fluid3D([14945,14537,14550,15393],0); -ELEMENTS[9362] = Fluid3D([15591,15255,15109,15717],0); -ELEMENTS[9363] = Fluid3D([15591,15393,15255,15874],0); -ELEMENTS[9364] = Fluid3D([15109,15591,15717,15707],0); -ELEMENTS[9365] = Fluid3D([15393,15255,15874,15433],0); -ELEMENTS[9366] = Fluid3D([15393,15255,15433,14550],0); -ELEMENTS[9367] = Fluid3D([15109,15591,15707,15167],0); -ELEMENTS[9368] = Fluid3D([15255,15874,15433,15671],0); -ELEMENTS[9369] = Fluid3D([15255,15874,15671,15717],0); -ELEMENTS[9370] = Fluid3D([15433,15255,15671,15328],0); -ELEMENTS[9371] = Fluid3D([15591,15255,15717,15874],0); -ELEMENTS[9372] = Fluid3D([15591,15717,15707,16177],0); -ELEMENTS[9373] = Fluid3D([15591,15717,16177,15874],0); -ELEMENTS[9374] = Fluid3D([15707,15591,16177,15757],0); -ELEMENTS[9375] = Fluid3D([15393,15591,15879,15874],0); -ELEMENTS[9376] = Fluid3D([15879,15591,15757,16177],0); -ELEMENTS[9377] = Fluid3D([15591,15167,15757,15707],0); -ELEMENTS[9378] = Fluid3D([15255,15109,15717,15026],0); -ELEMENTS[9379] = Fluid3D([15717,15109,15707,15506],0); -ELEMENTS[9380] = Fluid3D([15874,15393,15433,15902],0); -ELEMENTS[9381] = Fluid3D([14917,14407,14545,15140],0); -ELEMENTS[9382] = Fluid3D([15140,14917,15565,15297],0); -ELEMENTS[9383] = Fluid3D([14804,14354,15016,14454],0); -ELEMENTS[9384] = Fluid3D([14446,14420,14804,15100],0); -ELEMENTS[9385] = Fluid3D([14804,14446,15100,15121],0); -ELEMENTS[9386] = Fluid3D([14420,14804,15100,15186],0); -ELEMENTS[9387] = Fluid3D([14446,14420,15100,14614],0); -ELEMENTS[9388] = Fluid3D([14420,15100,14614,14944],0); -ELEMENTS[9389] = Fluid3D([14804,15100,15186,15438],0); -ELEMENTS[9390] = Fluid3D([14446,14420,14614,13753],0); -ELEMENTS[9391] = Fluid3D([14420,15100,14944,15186],0); -ELEMENTS[9392] = Fluid3D([15100,14446,14614,14975],0); -ELEMENTS[9393] = Fluid3D([15100,14446,14975,15121],0); -ELEMENTS[9394] = Fluid3D([14614,15100,14975,15307],0); -ELEMENTS[9395] = Fluid3D([14975,14614,15307,14980],0); -ELEMENTS[9396] = Fluid3D([14446,14614,14975,14202],0); -ELEMENTS[9397] = Fluid3D([14614,14975,14202,14980],0); -ELEMENTS[9398] = Fluid3D([14446,14614,14202,13753],0); -ELEMENTS[9399] = Fluid3D([14614,15100,15307,14944],0); -ELEMENTS[9400] = Fluid3D([15100,14975,15307,15606],0); -ELEMENTS[9401] = Fluid3D([15100,14975,15606,15121],0); -ELEMENTS[9402] = Fluid3D([14975,15307,15606,15497],0); -ELEMENTS[9403] = Fluid3D([15606,14975,15497,15485],0); -ELEMENTS[9404] = Fluid3D([15606,14975,15485,15121],0); -ELEMENTS[9405] = Fluid3D([14975,15307,15497,14980],0); -ELEMENTS[9406] = Fluid3D([15307,15100,15606,15649],0); -ELEMENTS[9407] = Fluid3D([15307,15100,15649,14944],0); -ELEMENTS[9408] = Fluid3D([15100,15606,15649,15438],0); -ELEMENTS[9409] = Fluid3D([15606,15307,15649,15935],0); -ELEMENTS[9410] = Fluid3D([15649,15606,15935,16146],0); -ELEMENTS[9411] = Fluid3D([15649,15606,16146,15796],0); -ELEMENTS[9412] = Fluid3D([15307,15649,15935,15643],0); -ELEMENTS[9413] = Fluid3D([15307,15649,15643,14944],0); -ELEMENTS[9414] = Fluid3D([15649,15606,15796,15438],0); -ELEMENTS[9415] = Fluid3D([15606,15307,15935,15497],0); -ELEMENTS[9416] = Fluid3D([15497,15606,15485,16045],0); -ELEMENTS[9417] = Fluid3D([15606,15485,16045,15954],0); -ELEMENTS[9418] = Fluid3D([15485,15497,16045,15962],0); -ELEMENTS[9419] = Fluid3D([15497,15606,16045,15935],0); -ELEMENTS[9420] = Fluid3D([15485,16045,15954,15707],0); -ELEMENTS[9421] = Fluid3D([15954,15485,15707,15167],0); -ELEMENTS[9422] = Fluid3D([15485,16045,15707,15962],0); -ELEMENTS[9423] = Fluid3D([15033,14354,14413,15021],0); -ELEMENTS[9424] = Fluid3D([14420,14804,15186,14454],0); -ELEMENTS[9425] = Fluid3D([15606,15485,15954,15121],0); -ELEMENTS[9426] = Fluid3D([16045,15606,15954,16146],0); -ELEMENTS[9427] = Fluid3D([13506,13967,14454,14354],0); -ELEMENTS[9428] = Fluid3D([13967,14401,14354,13315],0); -ELEMENTS[9429] = Fluid3D([14975,14446,14202,14453],0); -ELEMENTS[9430] = Fluid3D([15033,15121,15438,15757],0); -ELEMENTS[9431] = Fluid3D([13641,13506,13656,12817],0); -ELEMENTS[9432] = Fluid3D([14354,15033,15016,15145],0); -ELEMENTS[9433] = Fluid3D([14420,13641,14176,13954],0); -ELEMENTS[9434] = Fluid3D([14420,13641,13954,13753],0); -ELEMENTS[9435] = Fluid3D([13641,14176,13954,13489],0); -ELEMENTS[9436] = Fluid3D([13954,13641,13489,12878],0); -ELEMENTS[9437] = Fluid3D([13641,14176,13489,13656],0); -ELEMENTS[9438] = Fluid3D([14176,14420,13954,14944],0); -ELEMENTS[9439] = Fluid3D([14176,13954,13489,14188],0); -ELEMENTS[9440] = Fluid3D([13954,13489,14188,13464],0); -ELEMENTS[9441] = Fluid3D([13489,14188,13464,13472],0); -ELEMENTS[9442] = Fluid3D([13489,14188,13472,13963],0); -ELEMENTS[9443] = Fluid3D([14188,13472,13963,14269],0); -ELEMENTS[9444] = Fluid3D([14188,13464,13472,13942],0); -ELEMENTS[9445] = Fluid3D([14188,13464,13942,14253],0); -ELEMENTS[9446] = Fluid3D([13464,13472,13942,13047],0); -ELEMENTS[9447] = Fluid3D([14188,13464,14253,13954],0); -ELEMENTS[9448] = Fluid3D([13464,13472,13047,12675],0); -ELEMENTS[9449] = Fluid3D([13464,13472,12675,13489],0); -ELEMENTS[9450] = Fluid3D([13047,13464,12675,12656],0); -ELEMENTS[9451] = Fluid3D([12675,13047,12656,12141],0); -ELEMENTS[9452] = Fluid3D([12675,13047,12141,12569],0); -ELEMENTS[9453] = Fluid3D([12675,13047,12569,13472],0); -ELEMENTS[9454] = Fluid3D([14176,13954,14188,14944],0); -ELEMENTS[9455] = Fluid3D([13047,13464,12656,13430],0); -ELEMENTS[9456] = Fluid3D([13464,12656,13430,13319],0); -ELEMENTS[9457] = Fluid3D([12656,13430,13319,12864],0); -ELEMENTS[9458] = Fluid3D([13047,13464,13430,13942],0); -ELEMENTS[9459] = Fluid3D([13464,12656,13319,12881],0); -ELEMENTS[9460] = Fluid3D([12656,13319,12881,12441],0); -ELEMENTS[9461] = Fluid3D([13319,12881,12441,13125],0); -ELEMENTS[9462] = Fluid3D([12656,13319,12441,12864],0); -ELEMENTS[9463] = Fluid3D([13319,12441,12864,13166],0); -ELEMENTS[9464] = Fluid3D([13464,12656,12881,12675],0); -ELEMENTS[9465] = Fluid3D([13319,12881,13125,13954],0); -ELEMENTS[9466] = Fluid3D([13489,14188,13963,14176],0); -ELEMENTS[9467] = Fluid3D([14188,13472,14269,13942],0); -ELEMENTS[9468] = Fluid3D([13464,13942,14253,13430],0); -ELEMENTS[9469] = Fluid3D([13472,13963,14269,13632],0); -ELEMENTS[9470] = Fluid3D([13963,14269,13632,14425],0); -ELEMENTS[9471] = Fluid3D([14269,13632,14425,14266],0); -ELEMENTS[9472] = Fluid3D([13472,13963,13632,13325],0); -ELEMENTS[9473] = Fluid3D([13963,13632,13325,14053],0); -ELEMENTS[9474] = Fluid3D([14269,13632,14266,13673],0); -ELEMENTS[9475] = Fluid3D([14269,13632,13673,13472],0); -ELEMENTS[9476] = Fluid3D([13632,14266,13673,13451],0); -ELEMENTS[9477] = Fluid3D([13673,13632,13451,12569],0); -ELEMENTS[9478] = Fluid3D([14266,14269,13673,14486],0); -ELEMENTS[9479] = Fluid3D([14269,13673,14486,13942],0); -ELEMENTS[9480] = Fluid3D([13632,14266,13451,13929],0); -ELEMENTS[9481] = Fluid3D([14266,13451,13929,14170],0); -ELEMENTS[9482] = Fluid3D([13632,14266,13929,14425],0); -ELEMENTS[9483] = Fluid3D([14266,14269,14486,15002],0); -ELEMENTS[9484] = Fluid3D([14269,14486,15002,14892],0); -ELEMENTS[9485] = Fluid3D([14269,14486,14892,13942],0); -ELEMENTS[9486] = Fluid3D([14486,14266,15002,14887],0); -ELEMENTS[9487] = Fluid3D([14486,14266,14887,14132],0); -ELEMENTS[9488] = Fluid3D([14486,14266,14132,13673],0); -ELEMENTS[9489] = Fluid3D([14266,15002,14887,15018],0); -ELEMENTS[9490] = Fluid3D([14887,14266,15018,14787],0); -ELEMENTS[9491] = Fluid3D([15018,14887,14787,15432],0); -ELEMENTS[9492] = Fluid3D([14787,15018,15432,14878],0); -ELEMENTS[9493] = Fluid3D([14887,14787,15432,14974],0); -ELEMENTS[9494] = Fluid3D([14266,15018,14787,13929],0); -ELEMENTS[9495] = Fluid3D([15018,14887,15432,15002],0); -ELEMENTS[9496] = Fluid3D([14887,14266,14787,14132],0); -ELEMENTS[9497] = Fluid3D([14266,15002,15018,14425],0); -ELEMENTS[9498] = Fluid3D([14266,14269,15002,14425],0); -ELEMENTS[9499] = Fluid3D([13451,13632,13929,13026],0); -ELEMENTS[9500] = Fluid3D([13451,13632,13026,12569],0); -ELEMENTS[9501] = Fluid3D([13632,13929,13026,13251],0); -ELEMENTS[9502] = Fluid3D([13963,14269,14425,14788],0); -ELEMENTS[9503] = Fluid3D([14425,13963,14788,14629],0); -ELEMENTS[9504] = Fluid3D([13963,14269,14788,14188],0); -ELEMENTS[9505] = Fluid3D([14269,14425,14788,15002],0); -ELEMENTS[9506] = Fluid3D([13963,14788,14629,14176],0); -ELEMENTS[9507] = Fluid3D([14425,13963,14629,14053],0); -ELEMENTS[9508] = Fluid3D([14629,14425,14053,14809],0); -ELEMENTS[9509] = Fluid3D([14425,14053,14809,13929],0); -ELEMENTS[9510] = Fluid3D([14053,14629,14809,14310],0); -ELEMENTS[9511] = Fluid3D([14425,13963,14053,13632],0); -ELEMENTS[9512] = Fluid3D([14629,14425,14809,15130],0); -ELEMENTS[9513] = Fluid3D([14425,14809,15130,15018],0); -ELEMENTS[9514] = Fluid3D([14629,14425,15130,14788],0); -ELEMENTS[9515] = Fluid3D([14425,15130,14788,15002],0); -ELEMENTS[9516] = Fluid3D([15130,14629,14788,15098],0); -ELEMENTS[9517] = Fluid3D([14788,15130,15098,15453],0); -ELEMENTS[9518] = Fluid3D([14788,15130,15453,15002],0); -ELEMENTS[9519] = Fluid3D([15098,14788,15453,14969],0); -ELEMENTS[9520] = Fluid3D([15130,15098,15453,15727],0); -ELEMENTS[9521] = Fluid3D([14788,15453,14969,14892],0); -ELEMENTS[9522] = Fluid3D([15453,15130,15727,15527],0); -ELEMENTS[9523] = Fluid3D([15453,15130,15527,15002],0); -ELEMENTS[9524] = Fluid3D([15098,14788,14969,14176],0); -ELEMENTS[9525] = Fluid3D([15130,15098,15727,15228],0); -ELEMENTS[9526] = Fluid3D([15130,15098,15228,14629],0); -ELEMENTS[9527] = Fluid3D([15130,15727,15527,15692],0); -ELEMENTS[9528] = Fluid3D([15727,15130,15228,15692],0); -ELEMENTS[9529] = Fluid3D([15527,15130,15692,15018],0); -ELEMENTS[9530] = Fluid3D([14629,14788,15098,14176],0); -ELEMENTS[9531] = Fluid3D([15727,15453,15527,16094],0); -ELEMENTS[9532] = Fluid3D([14053,14425,13632,13929],0); -ELEMENTS[9533] = Fluid3D([15527,15727,16094,16197],0); -ELEMENTS[9534] = Fluid3D([16094,15527,16197,16270],0); -ELEMENTS[9535] = Fluid3D([16094,15527,16270,15848],0); -ELEMENTS[9536] = Fluid3D([16094,15527,15848,15453],0); -ELEMENTS[9537] = Fluid3D([15727,15453,16094,15760],0); -ELEMENTS[9538] = Fluid3D([15727,15453,15760,15098],0); -ELEMENTS[9539] = Fluid3D([15453,16094,15760,15876],0); -ELEMENTS[9540] = Fluid3D([15453,16094,15876,15848],0); -ELEMENTS[9541] = Fluid3D([15453,15098,14969,15760],0); -ELEMENTS[9542] = Fluid3D([15098,15727,15228,15612],0); -ELEMENTS[9543] = Fluid3D([15228,15098,15612,14916],0); -ELEMENTS[9544] = Fluid3D([15098,15727,15612,15760],0); -ELEMENTS[9545] = Fluid3D([15098,15612,14916,15341],0); -ELEMENTS[9546] = Fluid3D([15098,15612,15341,15760],0); -ELEMENTS[9547] = Fluid3D([14916,15098,15341,14714],0); -ELEMENTS[9548] = Fluid3D([14916,15098,14714,14629],0); -ELEMENTS[9549] = Fluid3D([15727,15228,15612,15835],0); -ELEMENTS[9550] = Fluid3D([15228,15612,15835,15516],0); -ELEMENTS[9551] = Fluid3D([15228,15612,15516,14916],0); -ELEMENTS[9552] = Fluid3D([15228,15098,14916,14629],0); -ELEMENTS[9553] = Fluid3D([15727,15527,15692,16197],0); -ELEMENTS[9554] = Fluid3D([15760,15453,15876,14969],0); -ELEMENTS[9555] = Fluid3D([14809,14629,15130,15228],0); -ELEMENTS[9556] = Fluid3D([15130,14809,15228,15692],0); -ELEMENTS[9557] = Fluid3D([15527,16270,15848,15810],0); -ELEMENTS[9558] = Fluid3D([15527,16270,15810,16020],0); -ELEMENTS[9559] = Fluid3D([15848,15527,15810,15002],0); -ELEMENTS[9560] = Fluid3D([15527,16270,16020,16197],0); -ELEMENTS[9561] = Fluid3D([16270,15848,15810,16247],0); -ELEMENTS[9562] = Fluid3D([15810,16270,16247,16407],0); -ELEMENTS[9563] = Fluid3D([15810,16270,16407,16020],0); -ELEMENTS[9564] = Fluid3D([15848,15810,16247,15645],0); -ELEMENTS[9565] = Fluid3D([15848,15810,15645,15002],0); -ELEMENTS[9566] = Fluid3D([15810,16247,15645,15970],0); -ELEMENTS[9567] = Fluid3D([15810,16247,15970,16407],0); -ELEMENTS[9568] = Fluid3D([16270,15848,16247,16436],0); -ELEMENTS[9569] = Fluid3D([16247,16270,16436,16723],0); -ELEMENTS[9570] = Fluid3D([16247,16270,16723,16407],0); -ELEMENTS[9571] = Fluid3D([16247,15645,15970,16119],0); -ELEMENTS[9572] = Fluid3D([15645,15970,16119,15567],0); -ELEMENTS[9573] = Fluid3D([15645,15970,15567,15318],0); -ELEMENTS[9574] = Fluid3D([15645,15970,15318,15810],0); -ELEMENTS[9575] = Fluid3D([16247,15645,16119,16099],0); -ELEMENTS[9576] = Fluid3D([16119,16247,16099,16614],0); -ELEMENTS[9577] = Fluid3D([16119,16247,16614,16552],0); -ELEMENTS[9578] = Fluid3D([16119,16247,16552,15970],0); -ELEMENTS[9579] = Fluid3D([16247,15645,16099,15848],0); -ELEMENTS[9580] = Fluid3D([16270,15848,16436,16094],0); -ELEMENTS[9581] = Fluid3D([16094,15727,15760,16273],0); -ELEMENTS[9582] = Fluid3D([15727,15760,16273,15612],0); -ELEMENTS[9583] = Fluid3D([16094,15727,16273,16197],0); -ELEMENTS[9584] = Fluid3D([15760,16094,16273,16386],0); -ELEMENTS[9585] = Fluid3D([15760,16094,16386,15876],0); -ELEMENTS[9586] = Fluid3D([16094,16273,16386,16709],0); -ELEMENTS[9587] = Fluid3D([16273,16386,16709,16735],0); -ELEMENTS[9588] = Fluid3D([16273,16386,16735,16383],0); -ELEMENTS[9589] = Fluid3D([16273,16386,16383,15760],0); -ELEMENTS[9590] = Fluid3D([16386,16709,16735,16888],0); -ELEMENTS[9591] = Fluid3D([16386,16709,16888,16436],0); -ELEMENTS[9592] = Fluid3D([16735,16386,16888,16685],0); -ELEMENTS[9593] = Fluid3D([16735,16386,16685,16383],0); -ELEMENTS[9594] = Fluid3D([16386,16888,16685,16572],0); -ELEMENTS[9595] = Fluid3D([16386,16888,16572,16436],0); -ELEMENTS[9596] = Fluid3D([16685,16386,16572,16235],0); -ELEMENTS[9597] = Fluid3D([16685,16386,16235,16383],0); -ELEMENTS[9598] = Fluid3D([16386,16572,16235,15876],0); -ELEMENTS[9599] = Fluid3D([16094,16273,16709,16197],0); -ELEMENTS[9600] = Fluid3D([16888,16735,16685,17150],0); -ELEMENTS[9601] = Fluid3D([16735,16685,17150,17070],0); -ELEMENTS[9602] = Fluid3D([17150,16735,17070,17208],0); -ELEMENTS[9603] = Fluid3D([17070,17150,17208,17514],0); -ELEMENTS[9604] = Fluid3D([17070,17150,17514,17356],0); -ELEMENTS[9605] = Fluid3D([17070,17150,17356,16903],0); -ELEMENTS[9606] = Fluid3D([17070,17150,16903,16685],0); -ELEMENTS[9607] = Fluid3D([17150,16903,16685,17107],0); -ELEMENTS[9608] = Fluid3D([16903,16685,17107,16642],0); -ELEMENTS[9609] = Fluid3D([16903,16685,16642,16383],0); -ELEMENTS[9610] = Fluid3D([17107,16903,16642,17102],0); -ELEMENTS[9611] = Fluid3D([17150,17208,17514,17410],0); -ELEMENTS[9612] = Fluid3D([17150,17356,16903,17107],0); -ELEMENTS[9613] = Fluid3D([17150,17514,17356,17488],0); -ELEMENTS[9614] = Fluid3D([17356,17070,16903,17135],0); -ELEMENTS[9615] = Fluid3D([16685,17107,16642,16741],0); -ELEMENTS[9616] = Fluid3D([17514,17070,17356,17550],0); -ELEMENTS[9617] = Fluid3D([17514,17150,17410,17488],0); -ELEMENTS[9618] = Fluid3D([16642,16685,16741,16235],0); -ELEMENTS[9619] = Fluid3D([16903,16642,17102,16640],0); -ELEMENTS[9620] = Fluid3D([16903,16642,16640,16383],0); -ELEMENTS[9621] = Fluid3D([17150,17410,17488,17166],0); -ELEMENTS[9622] = Fluid3D([17107,16903,17102,17356],0); -ELEMENTS[9623] = Fluid3D([17150,17208,17410,16888],0); -ELEMENTS[9624] = Fluid3D([17356,17150,17488,17107],0); -ELEMENTS[9625] = Fluid3D([17070,16903,17135,16752],0); -ELEMENTS[9626] = Fluid3D([17356,17070,17135,17550],0); -ELEMENTS[9627] = Fluid3D([17070,16903,16752,16814],0); -ELEMENTS[9628] = Fluid3D([16685,17107,16741,17166],0); -ELEMENTS[9629] = Fluid3D([17208,17070,17514,17323],0); -ELEMENTS[9630] = Fluid3D([17208,17070,17323,16814],0); -ELEMENTS[9631] = Fluid3D([17323,17208,16814,17073],0); -ELEMENTS[9632] = Fluid3D([17323,17208,17073,17497],0); -ELEMENTS[9633] = Fluid3D([17323,17208,17497,17514],0); -ELEMENTS[9634] = Fluid3D([17073,17323,17497,17485],0); -ELEMENTS[9635] = Fluid3D([17208,17073,17497,17195],0); -ELEMENTS[9636] = Fluid3D([17497,17208,17195,17410],0); -ELEMENTS[9637] = Fluid3D([17208,17073,17195,16709],0); -ELEMENTS[9638] = Fluid3D([17410,17488,17166,17557],0); -ELEMENTS[9639] = Fluid3D([17410,17488,17557,17770],0); -ELEMENTS[9640] = Fluid3D([17410,17488,17770,17514],0); -ELEMENTS[9641] = Fluid3D([17150,17410,17166,16888],0); -ELEMENTS[9642] = Fluid3D([17166,17150,16888,16685],0); -ELEMENTS[9643] = Fluid3D([17135,17070,16752,17108],0); -ELEMENTS[9644] = Fluid3D([17102,16903,16640,17135],0); -ELEMENTS[9645] = Fluid3D([17488,17150,17166,17107],0); -ELEMENTS[9646] = Fluid3D([16685,17150,17107,17166],0); -ELEMENTS[9647] = Fluid3D([16903,17102,17356,17135],0); -ELEMENTS[9648] = Fluid3D([16814,17323,17073,17053],0); -ELEMENTS[9649] = Fluid3D([17323,17073,17053,17485],0); -ELEMENTS[9650] = Fluid3D([17166,17410,17557,17261],0); -ELEMENTS[9651] = Fluid3D([17102,17107,17356,17642],0); -ELEMENTS[9652] = Fluid3D([17410,17166,16888,17261],0); -ELEMENTS[9653] = Fluid3D([17166,16888,17261,16919],0); -ELEMENTS[9654] = Fluid3D([17166,16888,16919,16572],0); -ELEMENTS[9655] = Fluid3D([16888,16919,16572,16436],0); -ELEMENTS[9656] = Fluid3D([17166,16888,16572,16685],0); -ELEMENTS[9657] = Fluid3D([17488,17166,17557,17414],0); -ELEMENTS[9658] = Fluid3D([16642,17102,16640,16763],0); -ELEMENTS[9659] = Fluid3D([17410,17557,17261,17645],0); -ELEMENTS[9660] = Fluid3D([17557,17488,17414,17772],0); -ELEMENTS[9661] = Fluid3D([17150,16735,17208,16888],0); -ELEMENTS[9662] = Fluid3D([17557,17488,17772,17770],0); -ELEMENTS[9663] = Fluid3D([17414,17557,17772,17687],0); -ELEMENTS[9664] = Fluid3D([17557,17772,17687,17896],0); -ELEMENTS[9665] = Fluid3D([17557,17772,17896,17770],0); -ELEMENTS[9666] = Fluid3D([17410,17557,17645,17770],0); -ELEMENTS[9667] = Fluid3D([17261,17166,16919,17343],0); -ELEMENTS[9668] = Fluid3D([17166,16919,17343,17036],0); -ELEMENTS[9669] = Fluid3D([17166,16919,17036,16572],0); -ELEMENTS[9670] = Fluid3D([17343,17166,17036,17414],0); -ELEMENTS[9671] = Fluid3D([17036,17343,17414,17369],0); -ELEMENTS[9672] = Fluid3D([17414,17036,17369,17234],0); -ELEMENTS[9673] = Fluid3D([17414,17036,17234,17107],0); -ELEMENTS[9674] = Fluid3D([17166,17036,17414,17107],0); -ELEMENTS[9675] = Fluid3D([17343,17414,17369,17687],0); -ELEMENTS[9676] = Fluid3D([17343,17414,17687,17557],0); -ELEMENTS[9677] = Fluid3D([17343,17414,17557,17166],0); -ELEMENTS[9678] = Fluid3D([17687,17343,17557,17643],0); -ELEMENTS[9679] = Fluid3D([17343,17557,17643,17261],0); -ELEMENTS[9680] = Fluid3D([17557,17343,17166,17261],0); -ELEMENTS[9681] = Fluid3D([17687,17343,17643,17504],0); -ELEMENTS[9682] = Fluid3D([17343,17643,17504,17297],0); -ELEMENTS[9683] = Fluid3D([17343,17643,17297,17261],0); -ELEMENTS[9684] = Fluid3D([17369,17343,17687,17504],0); -ELEMENTS[9685] = Fluid3D([17414,17369,17687,17644],0); -ELEMENTS[9686] = Fluid3D([17369,17414,17234,17644],0); -ELEMENTS[9687] = Fluid3D([17369,17687,17644,17822],0); -ELEMENTS[9688] = Fluid3D([17036,17369,17234,17096],0); -ELEMENTS[9689] = Fluid3D([17504,17343,17297,17067],0); -ELEMENTS[9690] = Fluid3D([17687,17369,17504,17822],0); -ELEMENTS[9691] = Fluid3D([17557,17687,17643,17896],0); -ELEMENTS[9692] = Fluid3D([17343,17297,17067,16919],0); -ELEMENTS[9693] = Fluid3D([17504,17343,17067,17369],0); -ELEMENTS[9694] = Fluid3D([17643,17504,17297,17691],0); -ELEMENTS[9695] = Fluid3D([16919,17343,17036,17067],0); -ELEMENTS[9696] = Fluid3D([17643,17504,17691,17858],0); -ELEMENTS[9697] = Fluid3D([17643,17504,17858,17687],0); -ELEMENTS[9698] = Fluid3D([17691,17643,17858,17855],0); -ELEMENTS[9699] = Fluid3D([17691,17643,17855,17560],0); -ELEMENTS[9700] = Fluid3D([17691,17643,17560,17297],0); -ELEMENTS[9701] = Fluid3D([17643,17858,17855,17896],0); -ELEMENTS[9702] = Fluid3D([17036,17343,17369,17067],0); -ELEMENTS[9703] = Fluid3D([17208,16814,17073,16735],0); -ELEMENTS[9704] = Fluid3D([17208,16814,16735,17070],0); -ELEMENTS[9705] = Fluid3D([16814,16735,17070,16685],0); -ELEMENTS[9706] = Fluid3D([17297,17504,17067,17292],0); -ELEMENTS[9707] = Fluid3D([17208,17514,17410,17497],0); -ELEMENTS[9708] = Fluid3D([17102,16640,16763,17167],0); -ELEMENTS[9709] = Fluid3D([16903,17135,16752,16640],0); -ELEMENTS[9710] = Fluid3D([17488,17166,17414,17107],0); -ELEMENTS[9711] = Fluid3D([17261,17410,17645,17336],0); -ELEMENTS[9712] = Fluid3D([17261,17410,17336,16888],0); -ELEMENTS[9713] = Fluid3D([17410,17645,17336,17652],0); -ELEMENTS[9714] = Fluid3D([17336,17410,17652,17195],0); -ELEMENTS[9715] = Fluid3D([17652,17336,17195,17530],0); -ELEMENTS[9716] = Fluid3D([17336,17195,17530,17146],0); -ELEMENTS[9717] = Fluid3D([17336,17195,17146,16933],0); -ELEMENTS[9718] = Fluid3D([17336,17195,16933,16888],0); -ELEMENTS[9719] = Fluid3D([17530,17336,17146,17492],0); -ELEMENTS[9720] = Fluid3D([17146,17336,16933,17289],0); -ELEMENTS[9721] = Fluid3D([17530,17336,17492,17645],0); -ELEMENTS[9722] = Fluid3D([17336,17146,17492,17289],0); -ELEMENTS[9723] = Fluid3D([17492,17336,17289,17645],0); -ELEMENTS[9724] = Fluid3D([17146,17492,17289,17304],0); -ELEMENTS[9725] = Fluid3D([17492,17289,17304,17560],0); -ELEMENTS[9726] = Fluid3D([17195,17146,16933,16802],0); -ELEMENTS[9727] = Fluid3D([17336,16933,17289,17261],0); -ELEMENTS[9728] = Fluid3D([17289,17336,17261,17645],0); -ELEMENTS[9729] = Fluid3D([16933,17195,16802,16709],0); -ELEMENTS[9730] = Fluid3D([16802,16933,16709,16270],0); -ELEMENTS[9731] = Fluid3D([17195,17146,16802,17225],0); -ELEMENTS[9732] = Fluid3D([17195,17146,17225,17530],0); -ELEMENTS[9733] = Fluid3D([16802,17195,17225,17073],0); -ELEMENTS[9734] = Fluid3D([16933,17195,16709,16888],0); -ELEMENTS[9735] = Fluid3D([16709,16933,16888,16436],0); -ELEMENTS[9736] = Fluid3D([17289,17146,17304,16723],0); -ELEMENTS[9737] = Fluid3D([17146,17492,17304,17447],0); -ELEMENTS[9738] = Fluid3D([17492,17304,17447,17594],0); -ELEMENTS[9739] = Fluid3D([17492,17304,17594,17560],0); -ELEMENTS[9740] = Fluid3D([17336,17410,17195,16888],0); -ELEMENTS[9741] = Fluid3D([17652,17336,17530,17645],0); -ELEMENTS[9742] = Fluid3D([17146,16933,16802,16723],0); -ELEMENTS[9743] = Fluid3D([17304,17447,17594,17408],0); -ELEMENTS[9744] = Fluid3D([17594,17304,17408,17335],0); -ELEMENTS[9745] = Fluid3D([17594,17304,17335,17434],0); -ELEMENTS[9746] = Fluid3D([17594,17304,17434,17560],0); -ELEMENTS[9747] = Fluid3D([17304,17447,17408,17056],0); -ELEMENTS[9748] = Fluid3D([17304,17447,17056,17146],0); -ELEMENTS[9749] = Fluid3D([17408,17304,17056,16934],0); -ELEMENTS[9750] = Fluid3D([17408,17304,16934,17335],0); -ELEMENTS[9751] = Fluid3D([17146,17530,17492,17447],0); -ELEMENTS[9752] = Fluid3D([17225,17195,17530,17497],0); -ELEMENTS[9753] = Fluid3D([17447,17492,17594,17802],0); -ELEMENTS[9754] = Fluid3D([17447,17492,17802,17530],0); -ELEMENTS[9755] = Fluid3D([17492,17594,17802,17805],0); -ELEMENTS[9756] = Fluid3D([17492,17594,17805,17560],0); -ELEMENTS[9757] = Fluid3D([17802,17492,17805,17796],0); -ELEMENTS[9758] = Fluid3D([17802,17492,17796,17530],0); -ELEMENTS[9759] = Fluid3D([17492,17805,17796,17645],0); -ELEMENTS[9760] = Fluid3D([17796,17492,17645,17530],0); -ELEMENTS[9761] = Fluid3D([17594,17802,17805,17951],0); -ELEMENTS[9762] = Fluid3D([17805,17594,17951,17799],0); -ELEMENTS[9763] = Fluid3D([17805,17594,17799,17560],0); -ELEMENTS[9764] = Fluid3D([17146,16802,17225,16891],0); -ELEMENTS[9765] = Fluid3D([17225,17146,16891,17447],0); -ELEMENTS[9766] = Fluid3D([17146,16802,16891,16723],0); -ELEMENTS[9767] = Fluid3D([16802,17225,16891,16771],0); -ELEMENTS[9768] = Fluid3D([17225,16891,16771,17164],0); -ELEMENTS[9769] = Fluid3D([17225,16891,17164,17447],0); -ELEMENTS[9770] = Fluid3D([17410,17645,17652,17770],0); -ELEMENTS[9771] = Fluid3D([16933,17146,17289,16723],0); -ELEMENTS[9772] = Fluid3D([17304,17335,17434,17019],0); -ELEMENTS[9773] = Fluid3D([17304,17335,17019,16934],0); -ELEMENTS[9774] = Fluid3D([17434,17304,17019,16905],0); -ELEMENTS[9775] = Fluid3D([17304,17019,16905,16723],0); -ELEMENTS[9776] = Fluid3D([17019,16905,16723,16614],0); -ELEMENTS[9777] = Fluid3D([17019,16905,16614,17082],0); -ELEMENTS[9778] = Fluid3D([17019,16905,17082,17434],0); -ELEMENTS[9779] = Fluid3D([16905,16614,17082,16852],0); -ELEMENTS[9780] = Fluid3D([17082,16905,16852,17297],0); -ELEMENTS[9781] = Fluid3D([16905,16614,16852,16436],0); -ELEMENTS[9782] = Fluid3D([16642,17107,17102,17048],0); -ELEMENTS[9783] = Fluid3D([17107,17102,17048,17642],0); -ELEMENTS[9784] = Fluid3D([17102,16642,17048,16763],0); -ELEMENTS[9785] = Fluid3D([17073,17497,17195,17225],0); -ELEMENTS[9786] = Fluid3D([17107,16642,16741,17048],0); -ELEMENTS[9787] = Fluid3D([17643,17557,17896,17645],0); -ELEMENTS[9788] = Fluid3D([17557,17261,17645,17643],0); -ELEMENTS[9789] = Fluid3D([16640,16642,16763,16286],0); -ELEMENTS[9790] = Fluid3D([16640,16642,16286,16328],0); -ELEMENTS[9791] = Fluid3D([16642,16286,16328,16146],0); -ELEMENTS[9792] = Fluid3D([16642,16286,16146,16763],0); -ELEMENTS[9793] = Fluid3D([16286,16328,16146,15981],0); -ELEMENTS[9794] = Fluid3D([16286,16328,15981,16285],0); -ELEMENTS[9795] = Fluid3D([16328,15981,16285,16383],0); -ELEMENTS[9796] = Fluid3D([16328,15981,16383,16235],0); -ELEMENTS[9797] = Fluid3D([16328,15981,16235,16146],0); -ELEMENTS[9798] = Fluid3D([16383,16328,16235,16642],0); -ELEMENTS[9799] = Fluid3D([16286,16328,16285,16640],0); -ELEMENTS[9800] = Fluid3D([16328,16285,16640,16383],0); -ELEMENTS[9801] = Fluid3D([16285,16286,16640,16444],0); -ELEMENTS[9802] = Fluid3D([16640,16285,16444,16678],0); -ELEMENTS[9803] = Fluid3D([16640,16285,16678,16752],0); -ELEMENTS[9804] = Fluid3D([16444,16640,16678,17167],0); -ELEMENTS[9805] = Fluid3D([16285,16444,16678,16167],0); -ELEMENTS[9806] = Fluid3D([16678,16285,16167,16322],0); -ELEMENTS[9807] = Fluid3D([16678,16285,16322,16752],0); -ELEMENTS[9808] = Fluid3D([16285,16444,16167,15858],0); -ELEMENTS[9809] = Fluid3D([16285,16444,15858,16286],0); -ELEMENTS[9810] = Fluid3D([16285,16167,16322,15616],0); -ELEMENTS[9811] = Fluid3D([16286,16640,16444,16763],0); -ELEMENTS[9812] = Fluid3D([16444,16167,15858,16068],0); -ELEMENTS[9813] = Fluid3D([15858,16444,16068,16115],0); -ELEMENTS[9814] = Fluid3D([15858,16444,16115,16286],0); -ELEMENTS[9815] = Fluid3D([16167,16322,15616,15900],0); -ELEMENTS[9816] = Fluid3D([15616,16167,15900,15550],0); -ELEMENTS[9817] = Fluid3D([15616,16167,15550,15858],0); -ELEMENTS[9818] = Fluid3D([16167,16285,15858,15616],0); -ELEMENTS[9819] = Fluid3D([16640,16642,16328,16383],0); -ELEMENTS[9820] = Fluid3D([16167,16678,16322,16515],0); -ELEMENTS[9821] = Fluid3D([16678,16322,16515,16818],0); -ELEMENTS[9822] = Fluid3D([16167,16678,16515,16611],0); -ELEMENTS[9823] = Fluid3D([16167,16678,16611,16444],0); -ELEMENTS[9824] = Fluid3D([16515,16678,16818,17197],0); -ELEMENTS[9825] = Fluid3D([16678,16322,16818,16752],0); -ELEMENTS[9826] = Fluid3D([16678,16515,16611,17197],0); -ELEMENTS[9827] = Fluid3D([16322,16515,16818,16363],0); -ELEMENTS[9828] = Fluid3D([16322,16285,15616,16100],0); -ELEMENTS[9829] = Fluid3D([16322,16285,16100,16752],0); -ELEMENTS[9830] = Fluid3D([16285,15616,16100,15981],0); -ELEMENTS[9831] = Fluid3D([16100,16285,15981,16383],0); -ELEMENTS[9832] = Fluid3D([15981,16100,16383,15672],0); -ELEMENTS[9833] = Fluid3D([16100,16383,15672,16150],0); -ELEMENTS[9834] = Fluid3D([16100,16383,16150,16752],0); -ELEMENTS[9835] = Fluid3D([16383,15981,15672,15760],0); -ELEMENTS[9836] = Fluid3D([15672,16383,15760,16150],0); -ELEMENTS[9837] = Fluid3D([15616,16322,16100,15841],0); -ELEMENTS[9838] = Fluid3D([16322,16100,15841,16380],0); -ELEMENTS[9839] = Fluid3D([16322,16100,16380,16752],0); -ELEMENTS[9840] = Fluid3D([17514,17356,17488,17871],0); -ELEMENTS[9841] = Fluid3D([17687,17414,17644,17772],0); -ELEMENTS[9842] = Fluid3D([17488,17414,17772,17571],0); -ELEMENTS[9843] = Fluid3D([17488,17414,17571,17107],0); -ELEMENTS[9844] = Fluid3D([17772,17488,17571,17871],0); -ELEMENTS[9845] = Fluid3D([17335,17594,17434,17799],0); -ELEMENTS[9846] = Fluid3D([17408,17594,17335,17631],0); -ELEMENTS[9847] = Fluid3D([17414,17772,17571,17644],0); -ELEMENTS[9848] = Fluid3D([17504,17297,17691,17292],0); -ELEMENTS[9849] = Fluid3D([17858,17691,17855,17971],0); -ELEMENTS[9850] = Fluid3D([17772,17687,17896,18046],0); -ELEMENTS[9851] = Fluid3D([16709,16735,16888,17208],0); -ELEMENTS[9852] = Fluid3D([14266,13673,13451,14132],0); -ELEMENTS[9853] = Fluid3D([14486,15002,14892,15645],0); -ELEMENTS[9854] = Fluid3D([17414,17234,17644,17571],0); -ELEMENTS[9855] = Fluid3D([16386,16094,16709,16436],0); -ELEMENTS[9856] = Fluid3D([16709,16273,16735,16646],0); -ELEMENTS[9857] = Fluid3D([16273,16735,16646,16814],0); -ELEMENTS[9858] = Fluid3D([16735,16646,16814,17073],0); -ELEMENTS[9859] = Fluid3D([16646,16814,17073,16731],0); -ELEMENTS[9860] = Fluid3D([17073,16646,16731,16779],0); -ELEMENTS[9861] = Fluid3D([17073,16646,16779,16802],0); -ELEMENTS[9862] = Fluid3D([16646,16814,16731,16150],0); -ELEMENTS[9863] = Fluid3D([16646,16731,16779,16318],0); -ELEMENTS[9864] = Fluid3D([16646,16731,16318,16150],0); -ELEMENTS[9865] = Fluid3D([16779,16646,16318,16197],0); -ELEMENTS[9866] = Fluid3D([16731,17073,16779,17174],0); -ELEMENTS[9867] = Fluid3D([17073,16779,17174,17225],0); -ELEMENTS[9868] = Fluid3D([16731,17073,17174,17053],0); -ELEMENTS[9869] = Fluid3D([16731,17073,17053,16814],0); -ELEMENTS[9870] = Fluid3D([17053,16731,16814,16624],0); -ELEMENTS[9871] = Fluid3D([17174,16731,17053,16998],0); -ELEMENTS[9872] = Fluid3D([16731,16779,16318,16512],0); -ELEMENTS[9873] = Fluid3D([16318,16731,16512,16274],0); -ELEMENTS[9874] = Fluid3D([16318,16731,16274,16150],0); -ELEMENTS[9875] = Fluid3D([16512,16318,16274,15952],0); -ELEMENTS[9876] = Fluid3D([16512,16318,15952,16284],0); -ELEMENTS[9877] = Fluid3D([16512,16318,16284,16779],0); -ELEMENTS[9878] = Fluid3D([16318,16274,15952,15835],0); -ELEMENTS[9879] = Fluid3D([15952,16318,15835,15692],0); -ELEMENTS[9880] = Fluid3D([16318,16274,15835,16150],0); -ELEMENTS[9881] = Fluid3D([16274,15952,15835,15516],0); -ELEMENTS[9882] = Fluid3D([16731,16779,16512,17174],0); -ELEMENTS[9883] = Fluid3D([16731,16512,16274,16868],0); -ELEMENTS[9884] = Fluid3D([16318,15952,16284,15692],0); -ELEMENTS[9885] = Fluid3D([15952,16512,16284,16202],0); -ELEMENTS[9886] = Fluid3D([16274,16512,15952,16178],0); -ELEMENTS[9887] = Fluid3D([15952,16512,16202,16178],0); -ELEMENTS[9888] = Fluid3D([16284,15952,16202,15738],0); -ELEMENTS[9889] = Fluid3D([16202,16284,15738,16217],0); -ELEMENTS[9890] = Fluid3D([16202,16284,16217,16672],0); -ELEMENTS[9891] = Fluid3D([16202,16284,16672,16512],0); -ELEMENTS[9892] = Fluid3D([16284,15952,15738,15692],0); -ELEMENTS[9893] = Fluid3D([16709,16273,16646,16197],0); -ELEMENTS[9894] = Fluid3D([15952,16274,16178,15710],0); -ELEMENTS[9895] = Fluid3D([15952,16274,15710,15516],0); -ELEMENTS[9896] = Fluid3D([16178,15952,15710,15625],0); -ELEMENTS[9897] = Fluid3D([16178,15952,15625,16202],0); -ELEMENTS[9898] = Fluid3D([16274,16178,15710,16159],0); -ELEMENTS[9899] = Fluid3D([15710,16178,15625,15802],0); -ELEMENTS[9900] = Fluid3D([16274,16178,16159,16868],0); -ELEMENTS[9901] = Fluid3D([16178,15710,16159,15802],0); -ELEMENTS[9902] = Fluid3D([15952,15710,15625,15293],0); -ELEMENTS[9903] = Fluid3D([15952,15710,15293,15516],0); -ELEMENTS[9904] = Fluid3D([15710,15293,15516,15043],0); -ELEMENTS[9905] = Fluid3D([15516,15710,15043,15487],0); -ELEMENTS[9906] = Fluid3D([15516,15710,15487,16019],0); -ELEMENTS[9907] = Fluid3D([15516,15710,16019,16274],0); -ELEMENTS[9908] = Fluid3D([15710,16019,16274,16159],0); -ELEMENTS[9909] = Fluid3D([16019,16274,16159,16624],0); -ELEMENTS[9910] = Fluid3D([15043,15516,15487,14905],0); -ELEMENTS[9911] = Fluid3D([15487,15516,16019,15530],0); -ELEMENTS[9912] = Fluid3D([15293,15516,15043,14310],0); -ELEMENTS[9913] = Fluid3D([15710,15487,16019,16159],0); -ELEMENTS[9914] = Fluid3D([15710,15043,15487,15802],0); -ELEMENTS[9915] = Fluid3D([15516,15487,14905,15530],0); -ELEMENTS[9916] = Fluid3D([15516,16019,15530,15612],0); -ELEMENTS[9917] = Fluid3D([15043,15516,14905,14310],0); -ELEMENTS[9918] = Fluid3D([14905,15516,15530,14916],0); -ELEMENTS[9919] = Fluid3D([15710,15293,15043,15625],0); -ELEMENTS[9920] = Fluid3D([15487,14905,15530,15135],0); -ELEMENTS[9921] = Fluid3D([16019,15487,15530,15841],0); -ELEMENTS[9922] = Fluid3D([15530,16019,15841,16100],0); -ELEMENTS[9923] = Fluid3D([15841,15530,16100,15616],0); -ELEMENTS[9924] = Fluid3D([15487,15043,14905,14857],0); -ELEMENTS[9925] = Fluid3D([15043,14905,14857,14254],0); -ELEMENTS[9926] = Fluid3D([14905,14857,14254,15135],0); -ELEMENTS[9927] = Fluid3D([14905,15487,14857,15135],0); -ELEMENTS[9928] = Fluid3D([15487,14857,15135,15370],0); -ELEMENTS[9929] = Fluid3D([15625,15952,15293,15738],0); -ELEMENTS[9930] = Fluid3D([15487,15043,14857,15379],0); -ELEMENTS[9931] = Fluid3D([15043,14857,15379,14511],0); -ELEMENTS[9932] = Fluid3D([15043,14857,14511,14254],0); -ELEMENTS[9933] = Fluid3D([15487,15043,15379,15802],0); -ELEMENTS[9934] = Fluid3D([15530,15516,15612,14916],0); -ELEMENTS[9935] = Fluid3D([14857,15379,14511,14890],0); -ELEMENTS[9936] = Fluid3D([14857,15379,14890,15370],0); -ELEMENTS[9937] = Fluid3D([14511,14857,14890,13981],0); -ELEMENTS[9938] = Fluid3D([14857,14890,13981,14652],0); -ELEMENTS[9939] = Fluid3D([13981,14857,14652,14254],0); -ELEMENTS[9940] = Fluid3D([14890,13981,14652,14363],0); -ELEMENTS[9941] = Fluid3D([13981,14652,14363,13795],0); -ELEMENTS[9942] = Fluid3D([14857,14652,14254,15135],0); -ELEMENTS[9943] = Fluid3D([14857,14652,15135,15370],0); -ELEMENTS[9944] = Fluid3D([14857,14890,14652,15370],0); -ELEMENTS[9945] = Fluid3D([13981,14652,13795,14254],0); -ELEMENTS[9946] = Fluid3D([15379,14511,14890,15085],0); -ELEMENTS[9947] = Fluid3D([14890,15379,15085,15488],0); -ELEMENTS[9948] = Fluid3D([14890,15379,15488,15370],0); -ELEMENTS[9949] = Fluid3D([14511,14890,15085,14394],0); -ELEMENTS[9950] = Fluid3D([14890,15085,14394,15041],0); -ELEMENTS[9951] = Fluid3D([14890,15085,15041,15488],0); -ELEMENTS[9952] = Fluid3D([14511,14890,14394,13981],0); -ELEMENTS[9953] = Fluid3D([15379,14511,15085,15221],0); -ELEMENTS[9954] = Fluid3D([15085,15379,15221,15802],0); -ELEMENTS[9955] = Fluid3D([15379,15221,15802,15043],0); -ELEMENTS[9956] = Fluid3D([14511,15085,15221,14624],0); -ELEMENTS[9957] = Fluid3D([15085,15221,14624,15308],0); -ELEMENTS[9958] = Fluid3D([15085,15221,15308,15802],0); -ELEMENTS[9959] = Fluid3D([14511,15085,14624,14394],0); -ELEMENTS[9960] = Fluid3D([15379,14511,15221,15043],0); -ELEMENTS[9961] = Fluid3D([16274,16512,16178,16868],0); -ELEMENTS[9962] = Fluid3D([16735,16709,16646,17073],0); -ELEMENTS[9963] = Fluid3D([15221,14511,14624,14546],0); -ELEMENTS[9964] = Fluid3D([14624,15221,14546,14962],0); -ELEMENTS[9965] = Fluid3D([14546,14624,14962,14049],0); -ELEMENTS[9966] = Fluid3D([14511,14624,14546,13701],0); -ELEMENTS[9967] = Fluid3D([15221,14511,14546,15043],0); -ELEMENTS[9968] = Fluid3D([14624,15221,14962,15308],0); -ELEMENTS[9969] = Fluid3D([15221,14546,14962,15625],0); -ELEMENTS[9970] = Fluid3D([14905,15516,14916,14310],0); -ELEMENTS[9971] = Fluid3D([16284,15738,16217,15969],0); -ELEMENTS[9972] = Fluid3D([16284,15738,15969,15692],0); -ELEMENTS[9973] = Fluid3D([16217,16284,15969,16530],0); -ELEMENTS[9974] = Fluid3D([16217,16284,16530,16672],0); -ELEMENTS[9975] = Fluid3D([15969,16217,16530,16219],0); -ELEMENTS[9976] = Fluid3D([16217,16530,16219,16659],0); -ELEMENTS[9977] = Fluid3D([16217,16530,16659,16672],0); -ELEMENTS[9978] = Fluid3D([15738,16217,15969,15839],0); -ELEMENTS[9979] = Fluid3D([16217,15969,15839,16219],0); -ELEMENTS[9980] = Fluid3D([16530,16219,16659,16780],0); -ELEMENTS[9981] = Fluid3D([16530,16219,16780,16396],0); -ELEMENTS[9982] = Fluid3D([16530,16219,16396,15969],0); -ELEMENTS[9983] = Fluid3D([15738,16217,15839,15797],0); -ELEMENTS[9984] = Fluid3D([16217,15839,15797,15735],0); -ELEMENTS[9985] = Fluid3D([16219,16659,16780,16620],0); -ELEMENTS[9986] = Fluid3D([15738,16217,15797,16202],0); -ELEMENTS[9987] = Fluid3D([16284,15969,16530,16335],0); -ELEMENTS[9988] = Fluid3D([16284,15969,16335,15692],0); -ELEMENTS[9989] = Fluid3D([16530,16284,16335,16771],0); -ELEMENTS[9990] = Fluid3D([16530,16284,16771,16672],0); -ELEMENTS[9991] = Fluid3D([16335,16530,16771,16891],0); -ELEMENTS[9992] = Fluid3D([16771,16530,16672,17164],0); -ELEMENTS[9993] = Fluid3D([16530,16771,16891,17164],0); -ELEMENTS[9994] = Fluid3D([15969,16530,16335,16396],0); -ELEMENTS[9995] = Fluid3D([15969,15738,15839,15315],0); -ELEMENTS[9996] = Fluid3D([15969,15738,15315,15692],0); -ELEMENTS[9997] = Fluid3D([15839,15969,15315,15572],0); -ELEMENTS[9998] = Fluid3D([15839,15969,15572,16219],0); -ELEMENTS[9999] = Fluid3D([15738,15839,15315,15146],0); -ELEMENTS[10000] = Fluid3D([15738,15839,15146,15797],0); -ELEMENTS[10001] = Fluid3D([15315,15839,15572,14878],0); -ELEMENTS[10002] = Fluid3D([15839,15315,15146,15087],0); -ELEMENTS[10003] = Fluid3D([15315,15146,15087,14592],0); -ELEMENTS[10004] = Fluid3D([15315,15146,14592,14809],0); -ELEMENTS[10005] = Fluid3D([15839,15315,15087,14878],0); -ELEMENTS[10006] = Fluid3D([15146,15839,15087,15232],0); -ELEMENTS[10007] = Fluid3D([15087,15146,15232,14516],0); -ELEMENTS[10008] = Fluid3D([15087,15146,14516,14592],0); -ELEMENTS[10009] = Fluid3D([15146,15839,15232,15797],0); -ELEMENTS[10010] = Fluid3D([15839,15087,15232,15735],0); -ELEMENTS[10011] = Fluid3D([15232,15839,15735,15797],0); -ELEMENTS[10012] = Fluid3D([16659,16530,16780,17164],0); -ELEMENTS[10013] = Fluid3D([15969,15315,15572,16020],0); -ELEMENTS[10014] = Fluid3D([15315,15738,15146,15152],0); -ELEMENTS[10015] = Fluid3D([15315,15738,15152,15692],0); -ELEMENTS[10016] = Fluid3D([15738,15146,15152,15625],0); -ELEMENTS[10017] = Fluid3D([15146,15315,15152,14809],0); -ELEMENTS[10018] = Fluid3D([15315,15152,14809,15692],0); -ELEMENTS[10019] = Fluid3D([15152,14809,15692,15228],0); -ELEMENTS[10020] = Fluid3D([15152,14809,15228,14310],0); -ELEMENTS[10021] = Fluid3D([15952,16202,15738,15625],0); -ELEMENTS[10022] = Fluid3D([16780,16530,16396,16891],0); -ELEMENTS[10023] = Fluid3D([13472,13489,13963,13325],0); -ELEMENTS[10024] = Fluid3D([12656,13047,13430,12620],0); -ELEMENTS[10025] = Fluid3D([13430,12656,12620,12563],0); -ELEMENTS[10026] = Fluid3D([13047,13430,12620,13408],0); -ELEMENTS[10027] = Fluid3D([13047,13430,13408,13942],0); -ELEMENTS[10028] = Fluid3D([12620,13047,13408,12623],0); -ELEMENTS[10029] = Fluid3D([13047,13408,12623,13432],0); -ELEMENTS[10030] = Fluid3D([13047,13408,13432,13942],0); -ELEMENTS[10031] = Fluid3D([12656,13047,12620,12141],0); -ELEMENTS[10032] = Fluid3D([13430,12620,13408,13286],0); -ELEMENTS[10033] = Fluid3D([12620,13408,13286,12286],0); -ELEMENTS[10034] = Fluid3D([13408,12623,13432,13288],0); -ELEMENTS[10035] = Fluid3D([13408,12623,13288,13037],0); -ELEMENTS[10036] = Fluid3D([12623,13432,13288,12822],0); -ELEMENTS[10037] = Fluid3D([13432,13408,13288,14086],0); -ELEMENTS[10038] = Fluid3D([13408,13288,14086,13972],0); -ELEMENTS[10039] = Fluid3D([13432,13408,14086,13942],0); -ELEMENTS[10040] = Fluid3D([13432,13288,12822,13717],0); -ELEMENTS[10041] = Fluid3D([13432,13288,13717,14086],0); -ELEMENTS[10042] = Fluid3D([13288,12822,13717,13135],0); -ELEMENTS[10043] = Fluid3D([13288,12822,13135,12413],0); -ELEMENTS[10044] = Fluid3D([13288,12822,12413,12623],0); -ELEMENTS[10045] = Fluid3D([12822,13717,13135,13185],0); -ELEMENTS[10046] = Fluid3D([12822,13432,13717,13673],0); -ELEMENTS[10047] = Fluid3D([13432,13717,13673,14086],0); -ELEMENTS[10048] = Fluid3D([12822,13432,13673,12569],0); -ELEMENTS[10049] = Fluid3D([13717,13135,13185,13864],0); -ELEMENTS[10050] = Fluid3D([13135,13185,13864,13077],0); -ELEMENTS[10051] = Fluid3D([13135,13185,13077,12292],0); -ELEMENTS[10052] = Fluid3D([13135,13185,12292,12822],0); -ELEMENTS[10053] = Fluid3D([13717,13135,13864,13957],0); -ELEMENTS[10054] = Fluid3D([13135,13864,13957,13609],0); -ELEMENTS[10055] = Fluid3D([13135,13864,13609,13077],0); -ELEMENTS[10056] = Fluid3D([13717,13135,13957,13288],0); -ELEMENTS[10057] = Fluid3D([12822,13717,13185,13451],0); -ELEMENTS[10058] = Fluid3D([12822,13135,12413,12292],0); -ELEMENTS[10059] = Fluid3D([12623,13432,12822,12569],0); -ELEMENTS[10060] = Fluid3D([12620,13047,12623,12141],0); -ELEMENTS[10061] = Fluid3D([13864,13717,13957,14500],0); -ELEMENTS[10062] = Fluid3D([13864,13717,14500,14132],0); -ELEMENTS[10063] = Fluid3D([13717,14500,14132,14486],0); -ELEMENTS[10064] = Fluid3D([13717,13957,14500,14086],0); -ELEMENTS[10065] = Fluid3D([13957,13864,14500,14489],0); -ELEMENTS[10066] = Fluid3D([13864,14500,14489,14630],0); -ELEMENTS[10067] = Fluid3D([14500,14489,14630,15165],0); -ELEMENTS[10068] = Fluid3D([14500,14489,15165,14856],0); -ELEMENTS[10069] = Fluid3D([14500,14489,14856,13957],0); -ELEMENTS[10070] = Fluid3D([13957,13864,14489,13609],0); -ELEMENTS[10071] = Fluid3D([14489,14630,15165,15188],0); -ELEMENTS[10072] = Fluid3D([13864,14500,14630,14132],0); -ELEMENTS[10073] = Fluid3D([14630,14500,15165,15036],0); -ELEMENTS[10074] = Fluid3D([15165,14630,15036,15674],0); -ELEMENTS[10075] = Fluid3D([14500,15165,15036,15567],0); -ELEMENTS[10076] = Fluid3D([14630,14500,15036,14132],0); -ELEMENTS[10077] = Fluid3D([14489,13864,14630,14070],0); -ELEMENTS[10078] = Fluid3D([13864,14630,14070,13677],0); -ELEMENTS[10079] = Fluid3D([14489,15165,14856,15162],0); -ELEMENTS[10080] = Fluid3D([14856,14489,15162,14433],0); -ELEMENTS[10081] = Fluid3D([15165,14856,15162,15549],0); -ELEMENTS[10082] = Fluid3D([14489,15165,15162,15188],0); -ELEMENTS[10083] = Fluid3D([15165,14856,15549,15567],0); -ELEMENTS[10084] = Fluid3D([15549,15165,15567,15852],0); -ELEMENTS[10085] = Fluid3D([15567,15549,15852,16107],0); -ELEMENTS[10086] = Fluid3D([15567,15549,16107,15515],0); -ELEMENTS[10087] = Fluid3D([15567,15549,15515,14856],0); -ELEMENTS[10088] = Fluid3D([15549,15852,16107,16065],0); -ELEMENTS[10089] = Fluid3D([15549,16107,15515,15925],0); -ELEMENTS[10090] = Fluid3D([15549,15852,16065,15162],0); -ELEMENTS[10091] = Fluid3D([16107,15567,15515,16119],0); -ELEMENTS[10092] = Fluid3D([16107,15567,16119,15970],0); -ELEMENTS[10093] = Fluid3D([15515,16107,16119,16282],0); -ELEMENTS[10094] = Fluid3D([16107,16119,16282,16520],0); -ELEMENTS[10095] = Fluid3D([16107,16119,16520,16552],0); -ELEMENTS[10096] = Fluid3D([16119,16520,16552,16614],0); -ELEMENTS[10097] = Fluid3D([16520,16552,16614,17019],0); -ELEMENTS[10098] = Fluid3D([16282,16107,16520,16522],0); -ELEMENTS[10099] = Fluid3D([16119,16282,16520,16614],0); -ELEMENTS[10100] = Fluid3D([16107,15549,16065,15925],0); -ELEMENTS[10101] = Fluid3D([15852,15567,16107,15970],0); -ELEMENTS[10102] = Fluid3D([15515,16107,16282,15925],0); -ELEMENTS[10103] = Fluid3D([16520,16552,17019,16880],0); -ELEMENTS[10104] = Fluid3D([16520,16552,16880,16367],0); -ELEMENTS[10105] = Fluid3D([16520,16552,16367,16107],0); -ELEMENTS[10106] = Fluid3D([16367,16520,16107,16506],0); -ELEMENTS[10107] = Fluid3D([16107,16367,16506,16065],0); -ELEMENTS[10108] = Fluid3D([16506,16107,16065,15925],0); -ELEMENTS[10109] = Fluid3D([16552,16880,16367,16584],0); -ELEMENTS[10110] = Fluid3D([16520,16107,16506,16522],0); -ELEMENTS[10111] = Fluid3D([16552,16880,16584,16934],0); -ELEMENTS[10112] = Fluid3D([16880,16584,16934,16991],0); -ELEMENTS[10113] = Fluid3D([16584,16934,16991,16793],0); -ELEMENTS[10114] = Fluid3D([16584,16934,16793,16407],0); -ELEMENTS[10115] = Fluid3D([16584,16552,16934,16407],0); -ELEMENTS[10116] = Fluid3D([16367,16552,16584,15970],0); -ELEMENTS[10117] = Fluid3D([16991,16584,16793,16564],0); -ELEMENTS[10118] = Fluid3D([16934,16991,16793,17408],0); -ELEMENTS[10119] = Fluid3D([16584,16793,16564,16509],0); -ELEMENTS[10120] = Fluid3D([16793,16564,16509,16882],0); -ELEMENTS[10121] = Fluid3D([16509,16793,16882,16923],0); -ELEMENTS[10122] = Fluid3D([16509,16793,16923,16396],0); -ELEMENTS[10123] = Fluid3D([16793,16882,16923,17328],0); -ELEMENTS[10124] = Fluid3D([16923,16793,17328,17056],0); -ELEMENTS[10125] = Fluid3D([16793,16882,17328,16991],0); -ELEMENTS[10126] = Fluid3D([16882,16509,16923,16490],0); -ELEMENTS[10127] = Fluid3D([16367,16520,16506,16880],0); -ELEMENTS[10128] = Fluid3D([16991,16584,16564,16633],0); -ELEMENTS[10129] = Fluid3D([16882,16509,16490,16564],0); -ELEMENTS[10130] = Fluid3D([16991,16584,16633,16880],0); -ELEMENTS[10131] = Fluid3D([16584,16564,16633,16138],0); -ELEMENTS[10132] = Fluid3D([16584,16633,16880,16367],0); -ELEMENTS[10133] = Fluid3D([16584,16633,16367,16138],0); -ELEMENTS[10134] = Fluid3D([16633,16367,16138,15852],0); -ELEMENTS[10135] = Fluid3D([16367,16138,15852,15970],0); -ELEMENTS[10136] = Fluid3D([16633,16880,16367,16506],0); -ELEMENTS[10137] = Fluid3D([16367,16584,16138,15970],0); -ELEMENTS[10138] = Fluid3D([16793,16564,16882,16991],0); -ELEMENTS[10139] = Fluid3D([16584,16564,16138,15865],0); -ELEMENTS[10140] = Fluid3D([15549,15165,15852,15162],0); -ELEMENTS[10141] = Fluid3D([16882,16923,17328,17076],0); -ELEMENTS[10142] = Fluid3D([16882,16923,17076,16490],0); -ELEMENTS[10143] = Fluid3D([16923,17328,17076,17282],0); -ELEMENTS[10144] = Fluid3D([17076,16923,17282,16870],0); -ELEMENTS[10145] = Fluid3D([16923,17328,17282,17056],0); -ELEMENTS[10146] = Fluid3D([16564,16633,16138,16164],0); -ELEMENTS[10147] = Fluid3D([16564,16991,16633,16901],0); -ELEMENTS[10148] = Fluid3D([16991,16633,16901,17089],0); -ELEMENTS[10149] = Fluid3D([16564,16991,16901,16882],0); -ELEMENTS[10150] = Fluid3D([16901,16991,17089,17310],0); -ELEMENTS[10151] = Fluid3D([16901,16991,17310,16882],0); -ELEMENTS[10152] = Fluid3D([16991,17089,17310,17362],0); -ELEMENTS[10153] = Fluid3D([16991,17089,17362,16880],0); -ELEMENTS[10154] = Fluid3D([16633,16564,16901,16164],0); -ELEMENTS[10155] = Fluid3D([16991,16633,17089,16880],0); -ELEMENTS[10156] = Fluid3D([15852,16107,16065,16367],0); -ELEMENTS[10157] = Fluid3D([15852,16107,16367,15970],0); -ELEMENTS[10158] = Fluid3D([16633,16901,17089,16769],0); -ELEMENTS[10159] = Fluid3D([17089,16633,16769,16782],0); -ELEMENTS[10160] = Fluid3D([16633,16901,16769,16164],0); -ELEMENTS[10161] = Fluid3D([17089,16633,16782,16880],0); -ELEMENTS[10162] = Fluid3D([17310,16991,17362,17328],0); -ELEMENTS[10163] = Fluid3D([17089,16901,17310,17229],0); -ELEMENTS[10164] = Fluid3D([16901,17089,16769,17229],0); -ELEMENTS[10165] = Fluid3D([16934,16880,16991,17335],0); -ELEMENTS[10166] = Fluid3D([16633,16769,16782,16324],0); -ELEMENTS[10167] = Fluid3D([16633,16769,16324,16164],0); -ELEMENTS[10168] = Fluid3D([16782,16633,16324,16506],0); -ELEMENTS[10169] = Fluid3D([16324,16782,16506,16554],0); -ELEMENTS[10170] = Fluid3D([16782,16506,16554,16944],0); -ELEMENTS[10171] = Fluid3D([16324,16782,16554,16769],0); -ELEMENTS[10172] = Fluid3D([17089,17310,17362,17527],0); -ELEMENTS[10173] = Fluid3D([17362,17089,17527,17349],0); -ELEMENTS[10174] = Fluid3D([17089,17310,17527,17229],0); -ELEMENTS[10175] = Fluid3D([17089,17527,17349,17286],0); -ELEMENTS[10176] = Fluid3D([17089,17527,17286,17229],0); -ELEMENTS[10177] = Fluid3D([17310,17362,17527,17683],0); -ELEMENTS[10178] = Fluid3D([17362,17527,17683,17708],0); -ELEMENTS[10179] = Fluid3D([17362,17527,17708,17349],0); -ELEMENTS[10180] = Fluid3D([17310,17362,17683,17506],0); -ELEMENTS[10181] = Fluid3D([17310,17362,17506,17328],0); -ELEMENTS[10182] = Fluid3D([17362,17683,17506,17631],0); -ELEMENTS[10183] = Fluid3D([17362,17683,17631,17708],0); -ELEMENTS[10184] = Fluid3D([17683,17506,17631,17775],0); -ELEMENTS[10185] = Fluid3D([17631,17683,17775,18043],0); -ELEMENTS[10186] = Fluid3D([17506,17362,17631,17408],0); -ELEMENTS[10187] = Fluid3D([17631,17506,17408,17775],0); -ELEMENTS[10188] = Fluid3D([17683,17631,17708,18043],0); -ELEMENTS[10189] = Fluid3D([17631,17362,17708,17335],0); -ELEMENTS[10190] = Fluid3D([17631,17362,17335,17408],0); -ELEMENTS[10191] = Fluid3D([17362,17335,17408,16991],0); -ELEMENTS[10192] = Fluid3D([17683,17506,17775,17599],0); -ELEMENTS[10193] = Fluid3D([17775,17683,17599,17862],0); -ELEMENTS[10194] = Fluid3D([17683,17599,17862,17628],0); -ELEMENTS[10195] = Fluid3D([17506,17775,17599,17537],0); -ELEMENTS[10196] = Fluid3D([17775,17599,17537,17881],0); -ELEMENTS[10197] = Fluid3D([17506,17775,17537,17408],0); -ELEMENTS[10198] = Fluid3D([17683,17506,17599,17310],0); -ELEMENTS[10199] = Fluid3D([17506,17362,17408,17328],0); -ELEMENTS[10200] = Fluid3D([17408,17506,17328,17537],0); -ELEMENTS[10201] = Fluid3D([17506,17328,17537,17599],0); -ELEMENTS[10202] = Fluid3D([17506,17328,17599,17310],0); -ELEMENTS[10203] = Fluid3D([17527,17349,17286,17647],0); -ELEMENTS[10204] = Fluid3D([17286,17527,17647,17621],0); -ELEMENTS[10205] = Fluid3D([17349,17286,17647,17348],0); -ELEMENTS[10206] = Fluid3D([17349,17286,17348,16782],0); -ELEMENTS[10207] = Fluid3D([17286,17647,17348,17298],0); -ELEMENTS[10208] = Fluid3D([17527,17349,17647,17708],0); -ELEMENTS[10209] = Fluid3D([17362,17089,17349,16880],0); -ELEMENTS[10210] = Fluid3D([14856,15162,15549,15236],0); -ELEMENTS[10211] = Fluid3D([16552,17019,16880,16934],0); -ELEMENTS[10212] = Fluid3D([16769,17089,16782,17286],0); -ELEMENTS[10213] = Fluid3D([12623,13047,13432,12569],0); -ELEMENTS[10214] = Fluid3D([13408,12620,12623,12286],0); -ELEMENTS[10215] = Fluid3D([13185,13717,13864,14132],0); -ELEMENTS[10216] = Fluid3D([16167,15858,16068,15550],0); -ELEMENTS[10217] = Fluid3D([16197,16094,16270,16709],0); -ELEMENTS[10218] = Fluid3D([13929,13451,13026,13421],0); -ELEMENTS[10219] = Fluid3D([13929,13451,13421,14170],0); -ELEMENTS[10220] = Fluid3D([13451,13026,13421,12572],0); -ELEMENTS[10221] = Fluid3D([13026,13929,13421,13385],0); -ELEMENTS[10222] = Fluid3D([13026,13421,12572,12586],0); -ELEMENTS[10223] = Fluid3D([13421,12572,12586,12546],0); -ELEMENTS[10224] = Fluid3D([13421,12572,12546,13144],0); -ELEMENTS[10225] = Fluid3D([13929,13421,13385,14012],0); -ELEMENTS[10226] = Fluid3D([13929,13421,14012,14221],0); -ELEMENTS[10227] = Fluid3D([13929,13421,14221,14170],0); -ELEMENTS[10228] = Fluid3D([12572,12546,13144,12209],0); -ELEMENTS[10229] = Fluid3D([12546,13144,12209,12719],0); -ELEMENTS[10230] = Fluid3D([12572,12546,12209,11713],0); -ELEMENTS[10231] = Fluid3D([12572,12546,11713,12586],0); -ELEMENTS[10232] = Fluid3D([13421,12572,13144,13451],0); -ELEMENTS[10233] = Fluid3D([12546,13144,12719,13473],0); -ELEMENTS[10234] = Fluid3D([13144,12719,13473,13393],0); -ELEMENTS[10235] = Fluid3D([12719,13473,13393,13698],0); -ELEMENTS[10236] = Fluid3D([13026,13421,12586,13385],0); -ELEMENTS[10237] = Fluid3D([13026,13929,13385,13251],0); -ELEMENTS[10238] = Fluid3D([13385,13026,13251,12586],0); -ELEMENTS[10239] = Fluid3D([13929,13385,13251,14065],0); -ELEMENTS[10240] = Fluid3D([13385,13251,14065,13380],0); -ELEMENTS[10241] = Fluid3D([13385,13251,13380,12666],0); -ELEMENTS[10242] = Fluid3D([13385,13251,12666,12586],0); -ELEMENTS[10243] = Fluid3D([14065,13385,13380,13903],0); -ELEMENTS[10244] = Fluid3D([13380,13385,12666,13110],0); -ELEMENTS[10245] = Fluid3D([14065,13385,13903,14012],0); -ELEMENTS[10246] = Fluid3D([13385,13380,13903,13110],0); -ELEMENTS[10247] = Fluid3D([13903,13385,13110,14012],0); -ELEMENTS[10248] = Fluid3D([13385,12666,13110,12586],0); -ELEMENTS[10249] = Fluid3D([13251,13380,12666,13015],0); -ELEMENTS[10250] = Fluid3D([13380,13903,13110,13542],0); -ELEMENTS[10251] = Fluid3D([13903,13110,13542,13775],0); -ELEMENTS[10252] = Fluid3D([13251,13380,13015,13551],0); -ELEMENTS[10253] = Fluid3D([13251,14065,13380,13551],0); -ELEMENTS[10254] = Fluid3D([13110,13380,13542,12551],0); -ELEMENTS[10255] = Fluid3D([13542,13110,12551,12809],0); -ELEMENTS[10256] = Fluid3D([13542,13110,12809,13775],0); -ELEMENTS[10257] = Fluid3D([13110,13380,12551,12666],0); -ELEMENTS[10258] = Fluid3D([13110,12551,12809,12122],0); -ELEMENTS[10259] = Fluid3D([13110,12551,12122,12666],0); -ELEMENTS[10260] = Fluid3D([12809,13110,12122,12681],0); -ELEMENTS[10261] = Fluid3D([12809,13110,12681,13775],0); -ELEMENTS[10262] = Fluid3D([13110,12122,12681,12447],0); -ELEMENTS[10263] = Fluid3D([13110,12122,12447,12666],0); -ELEMENTS[10264] = Fluid3D([13380,13903,13542,14180],0); -ELEMENTS[10265] = Fluid3D([13903,13542,14180,14516],0); -ELEMENTS[10266] = Fluid3D([13380,13903,14180,14065],0); -ELEMENTS[10267] = Fluid3D([12551,13542,12809,12940],0); -ELEMENTS[10268] = Fluid3D([13542,12809,12940,13783],0); -ELEMENTS[10269] = Fluid3D([12551,13542,12940,12849],0); -ELEMENTS[10270] = Fluid3D([12681,13110,12447,13366],0); -ELEMENTS[10271] = Fluid3D([12122,12809,12681,12014],0); -ELEMENTS[10272] = Fluid3D([12122,12809,12014,12016],0); -ELEMENTS[10273] = Fluid3D([12122,12809,12016,12551],0); -ELEMENTS[10274] = Fluid3D([13929,13385,14065,14012],0); -ELEMENTS[10275] = Fluid3D([13380,13542,12551,13350],0); -ELEMENTS[10276] = Fluid3D([13542,12551,13350,12849],0); -ELEMENTS[10277] = Fluid3D([12551,13380,13350,13015],0); -ELEMENTS[10278] = Fluid3D([13380,13350,13015,13875],0); -ELEMENTS[10279] = Fluid3D([13015,13380,13875,13551],0); -ELEMENTS[10280] = Fluid3D([13350,13015,13875,13603],0); -ELEMENTS[10281] = Fluid3D([13015,13875,13603,13551],0); -ELEMENTS[10282] = Fluid3D([13875,13603,13551,14310],0); -ELEMENTS[10283] = Fluid3D([13875,13603,14310,14546],0); -ELEMENTS[10284] = Fluid3D([13551,13875,14310,14065],0); -ELEMENTS[10285] = Fluid3D([13380,13350,13875,14180],0); -ELEMENTS[10286] = Fluid3D([13875,13380,14180,14065],0); -ELEMENTS[10287] = Fluid3D([13380,13542,13350,14180],0); -ELEMENTS[10288] = Fluid3D([13875,13350,13603,14546],0); -ELEMENTS[10289] = Fluid3D([12551,13350,12849,13015],0); -ELEMENTS[10290] = Fluid3D([12122,12681,12447,11757],0); -ELEMENTS[10291] = Fluid3D([12447,12122,11757,11542],0); -ELEMENTS[10292] = Fluid3D([12681,12447,11757,12484],0); -ELEMENTS[10293] = Fluid3D([12122,11757,11542,11131],0); -ELEMENTS[10294] = Fluid3D([12122,12681,11757,12014],0); -ELEMENTS[10295] = Fluid3D([12681,12447,12484,13366],0); -ELEMENTS[10296] = Fluid3D([12122,11757,11131,12014],0); -ELEMENTS[10297] = Fluid3D([12447,12122,11542,12666],0); -ELEMENTS[10298] = Fluid3D([12809,12551,12940,12016],0); -ELEMENTS[10299] = Fluid3D([12447,11757,12484,11789],0); -ELEMENTS[10300] = Fluid3D([12447,11757,11789,11542],0); -ELEMENTS[10301] = Fluid3D([12484,12447,11789,12546],0); -ELEMENTS[10302] = Fluid3D([12447,11789,12546,12586],0); -ELEMENTS[10303] = Fluid3D([12546,12447,12586,13421],0); -ELEMENTS[10304] = Fluid3D([12447,11789,12586,11542],0); -ELEMENTS[10305] = Fluid3D([12586,12447,11542,12666],0); -ELEMENTS[10306] = Fluid3D([12586,12447,12666,13110],0); -ELEMENTS[10307] = Fluid3D([12447,12586,13421,13110],0); -ELEMENTS[10308] = Fluid3D([11757,12484,11789,11561],0); -ELEMENTS[10309] = Fluid3D([11757,12484,11561,12089],0); -ELEMENTS[10310] = Fluid3D([11757,12484,12089,12681],0); -ELEMENTS[10311] = Fluid3D([12484,11789,11561,12075],0); -ELEMENTS[10312] = Fluid3D([11789,11561,12075,11082],0); -ELEMENTS[10313] = Fluid3D([11789,11561,11082,10705],0); -ELEMENTS[10314] = Fluid3D([11789,11561,10705,11757],0); -ELEMENTS[10315] = Fluid3D([12484,11561,12089,12344],0); -ELEMENTS[10316] = Fluid3D([12484,11789,12075,12546],0); -ELEMENTS[10317] = Fluid3D([11789,12075,12546,12209],0); -ELEMENTS[10318] = Fluid3D([12484,11561,12344,12075],0); -ELEMENTS[10319] = Fluid3D([11561,12089,12344,11544],0); -ELEMENTS[10320] = Fluid3D([12089,12344,11544,12417],0); -ELEMENTS[10321] = Fluid3D([12089,12344,12417,13103],0); -ELEMENTS[10322] = Fluid3D([12089,12344,13103,12484],0); -ELEMENTS[10323] = Fluid3D([11561,12089,11544,11081],0); -ELEMENTS[10324] = Fluid3D([11561,12089,11081,11757],0); -ELEMENTS[10325] = Fluid3D([12089,11544,11081,10974],0); -ELEMENTS[10326] = Fluid3D([12344,11561,11544,11609],0); -ELEMENTS[10327] = Fluid3D([11544,12344,11609,11832],0); -ELEMENTS[10328] = Fluid3D([11561,11544,11609,10776],0); -ELEMENTS[10329] = Fluid3D([11561,11544,10776,11081],0); -ELEMENTS[10330] = Fluid3D([11544,11609,10776,10896],0); -ELEMENTS[10331] = Fluid3D([12344,11561,11609,12075],0); -ELEMENTS[10332] = Fluid3D([11561,12075,11082,11609],0); -ELEMENTS[10333] = Fluid3D([12344,11544,12417,11832],0); -ELEMENTS[10334] = Fluid3D([13421,13385,14012,13110],0); -ELEMENTS[10335] = Fluid3D([11609,11561,10776,11082],0); -ELEMENTS[10336] = Fluid3D([12572,13026,12586,12061],0); -ELEMENTS[10337] = Fluid3D([12586,12572,12061,11713],0); -ELEMENTS[10338] = Fluid3D([12572,13026,12061,12569],0); -ELEMENTS[10339] = Fluid3D([13026,12586,12061,12485],0); -ELEMENTS[10340] = Fluid3D([13026,12586,12485,13251],0); -ELEMENTS[10341] = Fluid3D([12485,13026,13251,12562],0); -ELEMENTS[10342] = Fluid3D([12485,13026,12562,12061],0); -ELEMENTS[10343] = Fluid3D([13026,12562,12061,12569],0); -ELEMENTS[10344] = Fluid3D([12562,12485,12061,11783],0); -ELEMENTS[10345] = Fluid3D([13026,13251,12562,13632],0); -ELEMENTS[10346] = Fluid3D([13251,12485,12562,12659],0); -ELEMENTS[10347] = Fluid3D([13251,12485,12659,13015],0); -ELEMENTS[10348] = Fluid3D([12485,12562,12659,11783],0); -ELEMENTS[10349] = Fluid3D([12061,12562,11783,11950],0); -ELEMENTS[10350] = Fluid3D([12061,12562,11950,12569],0); -ELEMENTS[10351] = Fluid3D([12562,11783,11950,12524],0); -ELEMENTS[10352] = Fluid3D([12586,12061,12485,11542],0); -ELEMENTS[10353] = Fluid3D([13451,13026,12572,12569],0); -ELEMENTS[10354] = Fluid3D([12546,13421,13144,13473],0); -ELEMENTS[10355] = Fluid3D([12075,11789,11082,12209],0); -ELEMENTS[10356] = Fluid3D([11544,12089,12417,11681],0); -ELEMENTS[10357] = Fluid3D([11544,12089,11681,10974],0); -ELEMENTS[10358] = Fluid3D([11681,11544,10974,11115],0); -ELEMENTS[10359] = Fluid3D([11681,11544,11115,12417],0); -ELEMENTS[10360] = Fluid3D([10974,11681,11115,11108],0); -ELEMENTS[10361] = Fluid3D([10974,11681,11108,11336],0); -ELEMENTS[10362] = Fluid3D([10974,11681,11336,11591],0); -ELEMENTS[10363] = Fluid3D([10974,11681,11591,12089],0); -ELEMENTS[10364] = Fluid3D([11544,11115,12417,11832],0); -ELEMENTS[10365] = Fluid3D([11681,11115,11108,11998],0); -ELEMENTS[10366] = Fluid3D([11681,11115,11998,12417],0); -ELEMENTS[10367] = Fluid3D([11998,11681,12417,12543],0); -ELEMENTS[10368] = Fluid3D([12417,11998,12543,13157],0); -ELEMENTS[10369] = Fluid3D([12417,11998,13157,12673],0); -ELEMENTS[10370] = Fluid3D([13157,12417,12673,13652],0); -ELEMENTS[10371] = Fluid3D([11998,13157,12673,12474],0); -ELEMENTS[10372] = Fluid3D([13157,12673,12474,13633],0); -ELEMENTS[10373] = Fluid3D([12417,11998,12673,11115],0); -ELEMENTS[10374] = Fluid3D([11998,13157,12474,12174],0); -ELEMENTS[10375] = Fluid3D([11998,12543,13157,12174],0); -ELEMENTS[10376] = Fluid3D([12543,12417,13157,13272],0); -ELEMENTS[10377] = Fluid3D([11544,10974,11115,10377],0); -ELEMENTS[10378] = Fluid3D([11115,11544,10377,10776],0); -ELEMENTS[10379] = Fluid3D([11115,11544,10776,10896],0); -ELEMENTS[10380] = Fluid3D([11544,10377,10776,11081],0); -ELEMENTS[10381] = Fluid3D([10377,10776,11081,10705],0); -ELEMENTS[10382] = Fluid3D([11544,10377,11081,10974],0); -ELEMENTS[10383] = Fluid3D([10377,11081,10974,10680],0); -ELEMENTS[10384] = Fluid3D([10377,11081,10680,10705],0); -ELEMENTS[10385] = Fluid3D([11081,10974,10680,11591],0); -ELEMENTS[10386] = Fluid3D([11081,10974,11591,12089],0); -ELEMENTS[10387] = Fluid3D([11998,11681,12543,11108],0); -ELEMENTS[10388] = Fluid3D([10680,11081,11591,11757],0); -ELEMENTS[10389] = Fluid3D([10974,10680,11591,10596],0); -ELEMENTS[10390] = Fluid3D([11336,10974,11591,10596],0); -ELEMENTS[10391] = Fluid3D([11681,12417,12543,12089],0); -ELEMENTS[10392] = Fluid3D([11115,11108,11998,10703],0); -ELEMENTS[10393] = Fluid3D([12543,12417,13272,12089],0); -ELEMENTS[10394] = Fluid3D([12673,11998,12474,11709],0); -ELEMENTS[10395] = Fluid3D([11998,12474,11709,12174],0); -ELEMENTS[10396] = Fluid3D([12673,11998,11709,11115],0); -ELEMENTS[10397] = Fluid3D([12474,12673,11709,12500],0); -ELEMENTS[10398] = Fluid3D([11709,12474,12500,11870],0); -ELEMENTS[10399] = Fluid3D([12474,12500,11870,12843],0); -ELEMENTS[10400] = Fluid3D([12474,12500,12843,13633],0); -ELEMENTS[10401] = Fluid3D([12474,12673,12500,13633],0); -ELEMENTS[10402] = Fluid3D([11709,12474,11870,12051],0); -ELEMENTS[10403] = Fluid3D([12474,11870,12051,12843],0); -ELEMENTS[10404] = Fluid3D([11870,12051,12843,12129],0); -ELEMENTS[10405] = Fluid3D([11870,12051,12129,11230],0); -ELEMENTS[10406] = Fluid3D([11870,12051,11230,11016],0); -ELEMENTS[10407] = Fluid3D([12129,11870,11230,11433],0); -ELEMENTS[10408] = Fluid3D([12129,11870,11433,12391],0); -ELEMENTS[10409] = Fluid3D([12129,11870,12391,12843],0); -ELEMENTS[10410] = Fluid3D([11870,12391,12843,12500],0); -ELEMENTS[10411] = Fluid3D([12391,12843,12500,13680],0); -ELEMENTS[10412] = Fluid3D([11870,11230,11433,11124],0); -ELEMENTS[10413] = Fluid3D([11998,11709,11115,10703],0); -ELEMENTS[10414] = Fluid3D([12391,12129,12843,12981],0); -ELEMENTS[10415] = Fluid3D([12051,12129,11230,11918],0); -ELEMENTS[10416] = Fluid3D([11870,11433,12391,11908],0); -ELEMENTS[10417] = Fluid3D([11433,12129,12391,12531],0); -ELEMENTS[10418] = Fluid3D([12129,12391,12531,12981],0); -ELEMENTS[10419] = Fluid3D([12391,11433,12531,11983],0); -ELEMENTS[10420] = Fluid3D([12531,12391,11983,12953],0); -ELEMENTS[10421] = Fluid3D([12531,12391,12953,13389],0); -ELEMENTS[10422] = Fluid3D([12391,11983,12953,11908],0); -ELEMENTS[10423] = Fluid3D([12531,12391,13389,12981],0); -ELEMENTS[10424] = Fluid3D([12953,12531,13389,13474],0); -ELEMENTS[10425] = Fluid3D([12953,12531,13474,11983],0); -ELEMENTS[10426] = Fluid3D([13389,12953,13474,13914],0); -ELEMENTS[10427] = Fluid3D([12953,13474,13914,13442],0); -ELEMENTS[10428] = Fluid3D([12953,13474,13442,12584],0); -ELEMENTS[10429] = Fluid3D([12953,13474,12584,11983],0); -ELEMENTS[10430] = Fluid3D([12584,12953,11983,12482],0); -ELEMENTS[10431] = Fluid3D([13442,12953,12584,12482],0); -ELEMENTS[10432] = Fluid3D([13474,13442,12584,13363],0); -ELEMENTS[10433] = Fluid3D([12584,13474,13363,12672],0); -ELEMENTS[10434] = Fluid3D([12584,13474,12672,11983],0); -ELEMENTS[10435] = Fluid3D([11983,12584,12482,11756],0); -ELEMENTS[10436] = Fluid3D([11983,12584,11756,11891],0); -ELEMENTS[10437] = Fluid3D([11983,12584,11891,12672],0); -ELEMENTS[10438] = Fluid3D([13474,13442,13363,14008],0); -ELEMENTS[10439] = Fluid3D([12584,12482,11756,12594],0); -ELEMENTS[10440] = Fluid3D([13474,13363,12672,13508],0); -ELEMENTS[10441] = Fluid3D([12584,11756,11891,12156],0); -ELEMENTS[10442] = Fluid3D([11756,12584,12594,12156],0); -ELEMENTS[10443] = Fluid3D([12584,12482,12594,13442],0); -ELEMENTS[10444] = Fluid3D([13474,13363,13508,13895],0); -ELEMENTS[10445] = Fluid3D([13363,13508,13895,13448],0); -ELEMENTS[10446] = Fluid3D([13508,13895,13448,13746],0); -ELEMENTS[10447] = Fluid3D([13508,13895,13746,14201],0); -ELEMENTS[10448] = Fluid3D([13448,13508,13746,12672],0); -ELEMENTS[10449] = Fluid3D([13508,13474,13895,14201],0); -ELEMENTS[10450] = Fluid3D([13895,13448,13746,14204],0); -ELEMENTS[10451] = Fluid3D([13895,13448,14204,14008],0); -ELEMENTS[10452] = Fluid3D([13448,14204,14008,13854],0); -ELEMENTS[10453] = Fluid3D([13448,14204,13854,13685],0); -ELEMENTS[10454] = Fluid3D([13448,14204,13685,13746],0); -ELEMENTS[10455] = Fluid3D([13854,13448,13685,12982],0); -ELEMENTS[10456] = Fluid3D([14204,13854,13685,14429],0); -ELEMENTS[10457] = Fluid3D([13448,13685,12982,12976],0); -ELEMENTS[10458] = Fluid3D([13448,13685,12976,13746],0); -ELEMENTS[10459] = Fluid3D([13854,13448,12982,13059],0); -ELEMENTS[10460] = Fluid3D([14204,13854,14429,14627],0); -ELEMENTS[10461] = Fluid3D([13685,14204,14429,14419],0); -ELEMENTS[10462] = Fluid3D([13685,14204,14419,13746],0); -ELEMENTS[10463] = Fluid3D([13854,13448,13059,14008],0); -ELEMENTS[10464] = Fluid3D([14204,13854,14627,14008],0); -ELEMENTS[10465] = Fluid3D([13895,13448,14008,13363],0); -ELEMENTS[10466] = Fluid3D([13448,14008,13363,13059],0); -ELEMENTS[10467] = Fluid3D([14008,13363,13059,13654],0); -ELEMENTS[10468] = Fluid3D([13363,13059,13654,12594],0); -ELEMENTS[10469] = Fluid3D([14008,13363,13654,13442],0); -ELEMENTS[10470] = Fluid3D([13363,13448,13059,12672],0); -ELEMENTS[10471] = Fluid3D([13059,14008,13654,13854],0); -ELEMENTS[10472] = Fluid3D([12982,13448,12976,12655],0); -ELEMENTS[10473] = Fluid3D([13448,12982,13059,12655],0); -ELEMENTS[10474] = Fluid3D([14204,14429,14419,15113],0); -ELEMENTS[10475] = Fluid3D([14204,14429,15113,14627],0); -ELEMENTS[10476] = Fluid3D([13363,13508,13448,12672],0); -ELEMENTS[10477] = Fluid3D([14419,14204,15113,14702],0); -ELEMENTS[10478] = Fluid3D([13448,12976,12655,13746],0); -ELEMENTS[10479] = Fluid3D([12672,13474,13508,13222],0); -ELEMENTS[10480] = Fluid3D([11891,12584,12156,12672],0); -ELEMENTS[10481] = Fluid3D([11756,11983,11891,11077],0); -ELEMENTS[10482] = Fluid3D([12982,13854,13059,13158],0); -ELEMENTS[10483] = Fluid3D([13854,13059,13158,13840],0); -ELEMENTS[10484] = Fluid3D([11756,11983,11077,11440],0); -ELEMENTS[10485] = Fluid3D([11756,11983,11440,12482],0); -ELEMENTS[10486] = Fluid3D([11230,12129,11433,11397],0); -ELEMENTS[10487] = Fluid3D([13854,13059,13840,13654],0); -ELEMENTS[10488] = Fluid3D([13059,13840,13654,13004],0); -ELEMENTS[10489] = Fluid3D([13840,13654,13004,13752],0); -ELEMENTS[10490] = Fluid3D([13840,13654,13752,14395],0); -ELEMENTS[10491] = Fluid3D([13840,13654,14395,14627],0); -ELEMENTS[10492] = Fluid3D([13654,13004,13752,13111],0); -ELEMENTS[10493] = Fluid3D([13654,13752,14395,14039],0); -ELEMENTS[10494] = Fluid3D([13752,13840,14395,14335],0); -ELEMENTS[10495] = Fluid3D([13654,13059,13004,12594],0); -ELEMENTS[10496] = Fluid3D([13004,13840,13752,13499],0); -ELEMENTS[10497] = Fluid3D([13752,13654,13111,14039],0); -ELEMENTS[10498] = Fluid3D([14395,13654,14039,14249],0); -ELEMENTS[10499] = Fluid3D([14395,13654,14249,14008],0); -ELEMENTS[10500] = Fluid3D([13840,14395,14335,14627],0); -ELEMENTS[10501] = Fluid3D([13654,13004,13111,12594],0); -ELEMENTS[10502] = Fluid3D([13004,13111,12594,12398],0); -ELEMENTS[10503] = Fluid3D([13111,12594,12398,12556],0); -ELEMENTS[10504] = Fluid3D([13111,12594,12556,13167],0); -ELEMENTS[10505] = Fluid3D([13111,12594,13167,13442],0); -ELEMENTS[10506] = Fluid3D([12398,13111,12556,13062],0); -ELEMENTS[10507] = Fluid3D([12556,13111,13167,13478],0); -ELEMENTS[10508] = Fluid3D([12398,13111,13062,13752],0); -ELEMENTS[10509] = Fluid3D([13111,12556,13062,13478],0); -ELEMENTS[10510] = Fluid3D([13062,13111,13478,13752],0); -ELEMENTS[10511] = Fluid3D([12594,12556,13167,12482],0); -ELEMENTS[10512] = Fluid3D([13167,12594,12482,13442],0); -ELEMENTS[10513] = Fluid3D([12556,13062,13478,12897],0); -ELEMENTS[10514] = Fluid3D([13062,13478,12897,13684],0); -ELEMENTS[10515] = Fluid3D([13062,13478,13684,13900],0); -ELEMENTS[10516] = Fluid3D([13062,13478,13900,13752],0); -ELEMENTS[10517] = Fluid3D([13111,13167,13478,14039],0); -ELEMENTS[10518] = Fluid3D([13752,13840,14335,13499],0); -ELEMENTS[10519] = Fluid3D([13004,13840,13499,13158],0); -ELEMENTS[10520] = Fluid3D([12482,13167,13442,13317],0); -ELEMENTS[10521] = Fluid3D([13167,13442,13317,13985],0); -ELEMENTS[10522] = Fluid3D([13167,13442,13985,14039],0); -ELEMENTS[10523] = Fluid3D([12482,13167,13317,12421],0); -ELEMENTS[10524] = Fluid3D([13317,13167,13985,13547],0); -ELEMENTS[10525] = Fluid3D([13317,13167,13547,12421],0); -ELEMENTS[10526] = Fluid3D([13167,13985,13547,13478],0); -ELEMENTS[10527] = Fluid3D([12594,12398,12556,11732],0); -ELEMENTS[10528] = Fluid3D([12556,12594,11732,12482],0); -ELEMENTS[10529] = Fluid3D([13654,13111,14039,13442],0); -ELEMENTS[10530] = Fluid3D([13684,13062,13900,13516],0); -ELEMENTS[10531] = Fluid3D([12897,13062,13684,12707],0); -ELEMENTS[10532] = Fluid3D([13111,13654,12594,13442],0); -ELEMENTS[10533] = Fluid3D([13478,13111,14039,13752],0); -ELEMENTS[10534] = Fluid3D([13478,13684,13900,14358],0); -ELEMENTS[10535] = Fluid3D([13478,12897,13684,13776],0); -ELEMENTS[10536] = Fluid3D([13654,14039,14249,13442],0); -ELEMENTS[10537] = Fluid3D([13684,13478,13776,14358],0); -ELEMENTS[10538] = Fluid3D([13062,13684,12707,13516],0); -ELEMENTS[10539] = Fluid3D([13059,13840,13004,13158],0); -ELEMENTS[10540] = Fluid3D([12594,12398,11732,12156],0); -ELEMENTS[10541] = Fluid3D([13900,13478,14358,14039],0); -ELEMENTS[10542] = Fluid3D([13900,13478,14039,13752],0); -ELEMENTS[10543] = Fluid3D([14039,13900,13752,14395],0); -ELEMENTS[10544] = Fluid3D([13062,13900,13516,13752],0); -ELEMENTS[10545] = Fluid3D([12556,13062,12897,12279],0); -ELEMENTS[10546] = Fluid3D([13062,12897,12279,12707],0); -ELEMENTS[10547] = Fluid3D([13004,13111,12398,13752],0); -ELEMENTS[10548] = Fluid3D([13478,12897,13776,13031],0); -ELEMENTS[10549] = Fluid3D([13478,12897,13031,12556],0); -ELEMENTS[10550] = Fluid3D([13776,13478,13031,13547],0); -ELEMENTS[10551] = Fluid3D([13478,13031,13547,13167],0); -ELEMENTS[10552] = Fluid3D([13031,13547,13167,12421],0); -ELEMENTS[10553] = Fluid3D([13167,12556,13478,13031],0); -ELEMENTS[10554] = Fluid3D([14395,13752,14335,14521],0); -ELEMENTS[10555] = Fluid3D([14335,14395,14521,15012],0); -ELEMENTS[10556] = Fluid3D([14335,14395,15012,14627],0); -ELEMENTS[10557] = Fluid3D([13752,14335,14521,14021],0); -ELEMENTS[10558] = Fluid3D([13752,14335,14021,13499],0); -ELEMENTS[10559] = Fluid3D([12897,13776,13031,12877],0); -ELEMENTS[10560] = Fluid3D([13031,12897,12877,12186],0); -ELEMENTS[10561] = Fluid3D([14335,14521,14021,14913],0); -ELEMENTS[10562] = Fluid3D([12897,12877,12186,12356],0); -ELEMENTS[10563] = Fluid3D([12897,12877,12356,13269],0); -ELEMENTS[10564] = Fluid3D([13031,12897,12186,12556],0); -ELEMENTS[10565] = Fluid3D([12897,13776,12877,13269],0); -ELEMENTS[10566] = Fluid3D([12982,13854,13158,13470],0); -ELEMENTS[10567] = Fluid3D([12982,13854,13470,13685],0); -ELEMENTS[10568] = Fluid3D([13854,13158,13470,13973],0); -ELEMENTS[10569] = Fluid3D([13854,13158,13973,13840],0); -ELEMENTS[10570] = Fluid3D([13470,13854,13973,14429],0); -ELEMENTS[10571] = Fluid3D([13752,13004,13499,12997],0); -ELEMENTS[10572] = Fluid3D([13499,13752,12997,14021],0); -ELEMENTS[10573] = Fluid3D([13004,13499,12997,12553],0); -ELEMENTS[10574] = Fluid3D([13004,13499,12553,13158],0); -ELEMENTS[10575] = Fluid3D([13499,12997,12553,13057],0); -ELEMENTS[10576] = Fluid3D([13499,12997,13057,14021],0); -ELEMENTS[10577] = Fluid3D([11983,11077,11440,11433],0); -ELEMENTS[10578] = Fluid3D([13900,13684,13516,14374],0); -ELEMENTS[10579] = Fluid3D([13516,13900,14374,14021],0); -ELEMENTS[10580] = Fluid3D([13684,13516,14374,13882],0); -ELEMENTS[10581] = Fluid3D([13684,13516,13882,12707],0); -ELEMENTS[10582] = Fluid3D([13363,12584,12672,12156],0); -ELEMENTS[10583] = Fluid3D([13031,13776,13547,13390],0); -ELEMENTS[10584] = Fluid3D([13547,13031,13390,12421],0); -ELEMENTS[10585] = Fluid3D([12556,13062,12279,12398],0); -ELEMENTS[10586] = Fluid3D([12976,12982,12655,12133],0); -ELEMENTS[10587] = Fluid3D([12982,12655,12133,12195],0); -ELEMENTS[10588] = Fluid3D([12982,12655,12195,13059],0); -ELEMENTS[10589] = Fluid3D([12655,12976,12133,11944],0); -ELEMENTS[10590] = Fluid3D([12133,12655,11944,12195],0); -ELEMENTS[10591] = Fluid3D([14039,14395,14249,14946],0); -ELEMENTS[10592] = Fluid3D([11983,11891,11077,11433],0); -ELEMENTS[10593] = Fluid3D([13854,13685,14429,13470],0); -ELEMENTS[10594] = Fluid3D([12897,13684,13776,13269],0); -ELEMENTS[10595] = Fluid3D([13840,14335,13499,13973],0); -ELEMENTS[10596] = Fluid3D([12391,11433,11983,11908],0); -ELEMENTS[10597] = Fluid3D([13059,12982,13158,12195],0); -ELEMENTS[10598] = Fluid3D([14429,13685,14419,14166],0); -ELEMENTS[10599] = Fluid3D([13685,14419,14166,13755],0); -ELEMENTS[10600] = Fluid3D([14429,13685,14166,13470],0); -ELEMENTS[10601] = Fluid3D([14419,14166,13755,14514],0); -ELEMENTS[10602] = Fluid3D([14419,14166,14514,14928],0); -ELEMENTS[10603] = Fluid3D([14419,14429,14166,14928],0); -ELEMENTS[10604] = Fluid3D([13685,14419,13755,13746],0); -ELEMENTS[10605] = Fluid3D([14166,13685,13755,13279],0); -ELEMENTS[10606] = Fluid3D([14166,13685,13279,13470],0); -ELEMENTS[10607] = Fluid3D([13685,13755,13279,12976],0); -ELEMENTS[10608] = Fluid3D([13755,14419,14514,14461],0); -ELEMENTS[10609] = Fluid3D([13755,14419,14461,13733],0); -ELEMENTS[10610] = Fluid3D([14461,13755,13733,13851],0); -ELEMENTS[10611] = Fluid3D([13733,14461,13851,14024],0); -ELEMENTS[10612] = Fluid3D([14461,13755,13851,14514],0); -ELEMENTS[10613] = Fluid3D([13755,13733,13851,13049],0); -ELEMENTS[10614] = Fluid3D([13733,13851,13049,13142],0); -ELEMENTS[10615] = Fluid3D([12482,11756,12594,11732],0); -ELEMENTS[10616] = Fluid3D([11756,12594,11732,12156],0); -ELEMENTS[10617] = Fluid3D([13684,12897,12707,13269],0); -ELEMENTS[10618] = Fluid3D([11077,11756,11440,10679],0); -ELEMENTS[10619] = Fluid3D([11756,11440,10679,11732],0); -ELEMENTS[10620] = Fluid3D([10679,11756,11732,11207],0); -ELEMENTS[10621] = Fluid3D([11756,11732,11207,12156],0); -ELEMENTS[10622] = Fluid3D([10679,11756,11207,11077],0); -ELEMENTS[10623] = Fluid3D([13685,12982,12976,13279],0); -ELEMENTS[10624] = Fluid3D([13985,13317,13547,13886],0); -ELEMENTS[10625] = Fluid3D([13684,13900,14358,14374],0); -ELEMENTS[10626] = Fluid3D([14429,14419,15113,15227],0); -ELEMENTS[10627] = Fluid3D([15113,14429,15227,14627],0); -ELEMENTS[10628] = Fluid3D([14521,14335,15012,14913],0); -ELEMENTS[10629] = Fluid3D([11756,11891,12156,11207],0); -ELEMENTS[10630] = Fluid3D([14395,14521,15012,14883],0); -ELEMENTS[10631] = Fluid3D([13442,12584,13363,12594],0); -ELEMENTS[10632] = Fluid3D([13059,13363,12672,12156],0); -ELEMENTS[10633] = Fluid3D([11870,12391,12500,11908],0); -ELEMENTS[10634] = Fluid3D([12877,13031,12186,12534],0); -ELEMENTS[10635] = Fluid3D([13031,12186,12534,12421],0); -ELEMENTS[10636] = Fluid3D([12877,13031,12534,13390],0); -ELEMENTS[10637] = Fluid3D([13031,12534,13390,12421],0); -ELEMENTS[10638] = Fluid3D([12877,13031,13390,13776],0); -ELEMENTS[10639] = Fluid3D([12534,12877,13390,13118],0); -ELEMENTS[10640] = Fluid3D([13390,12534,13118,12711],0); -ELEMENTS[10641] = Fluid3D([12877,13390,13118,13295],0); -ELEMENTS[10642] = Fluid3D([12534,12877,13118,12261],0); -ELEMENTS[10643] = Fluid3D([13118,12534,12261,12185],0); -ELEMENTS[10644] = Fluid3D([13118,12534,12185,12711],0); -ELEMENTS[10645] = Fluid3D([12261,13118,12185,12224],0); -ELEMENTS[10646] = Fluid3D([13118,12185,12224,12892],0); -ELEMENTS[10647] = Fluid3D([13118,12185,12892,12711],0); -ELEMENTS[10648] = Fluid3D([12877,13118,12261,13051],0); -ELEMENTS[10649] = Fluid3D([12534,12261,12185,11567],0); -ELEMENTS[10650] = Fluid3D([12185,12534,11567,12711],0); -ELEMENTS[10651] = Fluid3D([12534,12261,11567,12186],0); -ELEMENTS[10652] = Fluid3D([12261,13118,12224,13051],0); -ELEMENTS[10653] = Fluid3D([12224,13118,12892,13051],0); -ELEMENTS[10654] = Fluid3D([12534,12877,12261,12186],0); -ELEMENTS[10655] = Fluid3D([12185,12261,12224,11429],0); -ELEMENTS[10656] = Fluid3D([12261,12185,11567,11429],0); -ELEMENTS[10657] = Fluid3D([12261,12224,11429,12325],0); -ELEMENTS[10658] = Fluid3D([12185,12224,12892,11963],0); -ELEMENTS[10659] = Fluid3D([12892,12185,11963,12348],0); -ELEMENTS[10660] = Fluid3D([12892,12185,12348,12711],0); -ELEMENTS[10661] = Fluid3D([12185,12224,11963,11429],0); -ELEMENTS[10662] = Fluid3D([12224,12892,11963,12635],0); -ELEMENTS[10663] = Fluid3D([12892,11963,12635,12645],0); -ELEMENTS[10664] = Fluid3D([12892,11963,12645,12348],0); -ELEMENTS[10665] = Fluid3D([12224,12892,12635,13554],0); -ELEMENTS[10666] = Fluid3D([12892,12635,13554,12645],0); -ELEMENTS[10667] = Fluid3D([11963,12224,12635,11769],0); -ELEMENTS[10668] = Fluid3D([12185,11963,12348,11604],0); -ELEMENTS[10669] = Fluid3D([11963,12635,12645,11926],0); -ELEMENTS[10670] = Fluid3D([12645,11963,11926,11721],0); -ELEMENTS[10671] = Fluid3D([11963,12635,11926,11796],0); -ELEMENTS[10672] = Fluid3D([11963,12635,11796,11769],0); -ELEMENTS[10673] = Fluid3D([11963,11926,11721,11062],0); -ELEMENTS[10674] = Fluid3D([11963,11926,11062,11796],0); -ELEMENTS[10675] = Fluid3D([12635,12645,11926,12846],0); -ELEMENTS[10676] = Fluid3D([12645,11926,12846,12327],0); -ELEMENTS[10677] = Fluid3D([12645,11926,12327,11721],0); -ELEMENTS[10678] = Fluid3D([11926,11721,11062,11181],0); -ELEMENTS[10679] = Fluid3D([11721,11062,11181,10706],0); -ELEMENTS[10680] = Fluid3D([11721,11062,10706,11149],0); -ELEMENTS[10681] = Fluid3D([11721,11062,11149,11963],0); -ELEMENTS[10682] = Fluid3D([11926,11721,11181,12327],0); -ELEMENTS[10683] = Fluid3D([12635,12645,12846,13554],0); -ELEMENTS[10684] = Fluid3D([12645,11963,11721,12348],0); -ELEMENTS[10685] = Fluid3D([11062,11926,11181,10926],0); -ELEMENTS[10686] = Fluid3D([11062,11926,10926,11796],0); -ELEMENTS[10687] = Fluid3D([11181,11062,10926,10239],0); -ELEMENTS[10688] = Fluid3D([11926,11181,10926,11739],0); -ELEMENTS[10689] = Fluid3D([11181,11062,10239,10706],0); -ELEMENTS[10690] = Fluid3D([11926,11181,11739,12327],0); -ELEMENTS[10691] = Fluid3D([10926,11181,10239,10623],0); -ELEMENTS[10692] = Fluid3D([11181,10239,10623,10318],0); -ELEMENTS[10693] = Fluid3D([11181,10239,10318,10706],0); -ELEMENTS[10694] = Fluid3D([10239,10926,10623,10007],0); -ELEMENTS[10695] = Fluid3D([10239,10926,10007,10263],0); -ELEMENTS[10696] = Fluid3D([10926,10623,10007,10960],0); -ELEMENTS[10697] = Fluid3D([10926,11181,10623,11739],0); -ELEMENTS[10698] = Fluid3D([10926,10623,10960,11739],0); -ELEMENTS[10699] = Fluid3D([10623,10007,10960,10068],0); -ELEMENTS[10700] = Fluid3D([10007,10960,10068,10149],0); -ELEMENTS[10701] = Fluid3D([10007,10960,10149,10868],0); -ELEMENTS[10702] = Fluid3D([10007,10960,10868,10926],0); -ELEMENTS[10703] = Fluid3D([10623,10007,10068,9429],0); -ELEMENTS[10704] = Fluid3D([10623,10007,9429,10239],0); -ELEMENTS[10705] = Fluid3D([10960,10623,10068,11002],0); -ELEMENTS[10706] = Fluid3D([10068,10623,9429,10074],0); -ELEMENTS[10707] = Fluid3D([10960,10623,11002,11739],0); -ELEMENTS[10708] = Fluid3D([10623,10068,11002,10074],0); -ELEMENTS[10709] = Fluid3D([11062,10926,10239,10263],0); -ELEMENTS[10710] = Fluid3D([10960,10068,10149,10712],0); -ELEMENTS[10711] = Fluid3D([12953,11983,12482,11908],0); -ELEMENTS[10712] = Fluid3D([12897,12556,12279,12186],0); -ELEMENTS[10713] = Fluid3D([11891,11756,11077,11207],0); -ELEMENTS[10714] = Fluid3D([14521,13752,14021,13900],0); -ELEMENTS[10715] = Fluid3D([14521,13752,13900,14395],0); -ELEMENTS[10716] = Fluid3D([13752,14021,13900,13516],0); -ELEMENTS[10717] = Fluid3D([14021,14521,13900,14374],0); -ELEMENTS[10718] = Fluid3D([14521,13900,14374,14358],0); -ELEMENTS[10719] = Fluid3D([12398,12556,11732,12279],0); -ELEMENTS[10720] = Fluid3D([13157,12543,13272,13337],0); -ELEMENTS[10721] = Fluid3D([12997,12553,13057,12217],0); -ELEMENTS[10722] = Fluid3D([13057,12997,12217,12829],0); -ELEMENTS[10723] = Fluid3D([12997,12217,12829,12412],0); -ELEMENTS[10724] = Fluid3D([12997,12553,12217,12398],0); -ELEMENTS[10725] = Fluid3D([12217,12829,12412,12076],0); -ELEMENTS[10726] = Fluid3D([12829,12412,12076,12707],0); -ELEMENTS[10727] = Fluid3D([12217,12829,12076,12443],0); -ELEMENTS[10728] = Fluid3D([12829,12076,12443,12766],0); -ELEMENTS[10729] = Fluid3D([12829,12076,12766,12908],0); -ELEMENTS[10730] = Fluid3D([12829,12076,12908,12707],0); -ELEMENTS[10731] = Fluid3D([12076,12443,12766,11866],0); -ELEMENTS[10732] = Fluid3D([12076,12443,11866,11460],0); -ELEMENTS[10733] = Fluid3D([12076,12443,11460,12217],0); -ELEMENTS[10734] = Fluid3D([12217,12829,12443,13057],0); -ELEMENTS[10735] = Fluid3D([12908,12829,12707,13516],0); -ELEMENTS[10736] = Fluid3D([12707,12908,13516,13882],0); -ELEMENTS[10737] = Fluid3D([12997,12217,12412,12398],0); -ELEMENTS[10738] = Fluid3D([12412,12997,12398,13062],0); -ELEMENTS[10739] = Fluid3D([12398,12412,13062,12279],0); -ELEMENTS[10740] = Fluid3D([12412,13062,12279,12707],0); -ELEMENTS[10741] = Fluid3D([12398,12412,12279,11559],0); -ELEMENTS[10742] = Fluid3D([12412,12279,11559,11765],0); -ELEMENTS[10743] = Fluid3D([12412,12279,11765,12707],0); -ELEMENTS[10744] = Fluid3D([11559,12412,11765,12076],0); -ELEMENTS[10745] = Fluid3D([12412,11765,12076,12707],0); -ELEMENTS[10746] = Fluid3D([12412,12997,13062,13516],0); -ELEMENTS[10747] = Fluid3D([12412,13062,12707,13516],0); -ELEMENTS[10748] = Fluid3D([12398,12412,11559,12217],0); -ELEMENTS[10749] = Fluid3D([12997,12398,13062,13752],0); -ELEMENTS[10750] = Fluid3D([12279,11559,11765,11188],0); -ELEMENTS[10751] = Fluid3D([11765,12279,11188,11788],0); -ELEMENTS[10752] = Fluid3D([11765,12279,11788,12707],0); -ELEMENTS[10753] = Fluid3D([12279,11559,11188,11732],0); -ELEMENTS[10754] = Fluid3D([12279,11188,11788,12186],0); -ELEMENTS[10755] = Fluid3D([11188,11765,11788,10771],0); -ELEMENTS[10756] = Fluid3D([11765,11788,10771,11946],0); -ELEMENTS[10757] = Fluid3D([11765,11788,11946,12707],0); -ELEMENTS[10758] = Fluid3D([10771,11765,11946,11374],0); -ELEMENTS[10759] = Fluid3D([10771,11765,11374,10454],0); -ELEMENTS[10760] = Fluid3D([10771,11765,10454,11188],0); -ELEMENTS[10761] = Fluid3D([11765,11946,11374,12076],0); -ELEMENTS[10762] = Fluid3D([11374,11765,12076,10454],0); -ELEMENTS[10763] = Fluid3D([11559,11765,11188,10454],0); -ELEMENTS[10764] = Fluid3D([11788,10771,11946,11305],0); -ELEMENTS[10765] = Fluid3D([11946,11788,11305,12255],0); -ELEMENTS[10766] = Fluid3D([11788,11305,12255,11489],0); -ELEMENTS[10767] = Fluid3D([12255,11788,11489,12356],0); -ELEMENTS[10768] = Fluid3D([12255,11788,12356,12707],0); -ELEMENTS[10769] = Fluid3D([11788,11489,12356,12186],0); -ELEMENTS[10770] = Fluid3D([11489,12255,12356,12325],0); -ELEMENTS[10771] = Fluid3D([12255,12356,12325,12994],0); -ELEMENTS[10772] = Fluid3D([11788,10771,11305,11489],0); -ELEMENTS[10773] = Fluid3D([11788,11188,10771,11489],0); -ELEMENTS[10774] = Fluid3D([11374,10771,10454,10278],0); -ELEMENTS[10775] = Fluid3D([11946,10771,11374,11084],0); -ELEMENTS[10776] = Fluid3D([10771,11946,11305,11084],0); -ELEMENTS[10777] = Fluid3D([11305,11946,12255,12112],0); -ELEMENTS[10778] = Fluid3D([11374,10771,10278,11084],0); -ELEMENTS[10779] = Fluid3D([12553,13057,12217,12228],0); -ELEMENTS[10780] = Fluid3D([13057,12217,12228,12443],0); -ELEMENTS[10781] = Fluid3D([12553,13057,12228,13188],0); -ELEMENTS[10782] = Fluid3D([12553,13057,13188,13499],0); -ELEMENTS[10783] = Fluid3D([12228,12553,13188,12145],0); -ELEMENTS[10784] = Fluid3D([13188,12228,12145,12385],0); -ELEMENTS[10785] = Fluid3D([13188,12228,12385,12948],0); -ELEMENTS[10786] = Fluid3D([13188,12228,12948,13057],0); -ELEMENTS[10787] = Fluid3D([12228,12553,12145,11285],0); -ELEMENTS[10788] = Fluid3D([12553,12145,11285,11987],0); -ELEMENTS[10789] = Fluid3D([12553,12145,11987,13158],0); -ELEMENTS[10790] = Fluid3D([12228,12553,11285,12217],0); -ELEMENTS[10791] = Fluid3D([12412,12217,12076,11559],0); -ELEMENTS[10792] = Fluid3D([12145,13188,12385,12805],0); -ELEMENTS[10793] = Fluid3D([12145,13188,12805,13158],0); -ELEMENTS[10794] = Fluid3D([13188,12385,12805,13231],0); -ELEMENTS[10795] = Fluid3D([13188,12385,13231,12948],0); -ELEMENTS[10796] = Fluid3D([12805,13188,13231,13683],0); -ELEMENTS[10797] = Fluid3D([12805,13188,13683,13158],0); -ELEMENTS[10798] = Fluid3D([12385,12145,12805,11856],0); -ELEMENTS[10799] = Fluid3D([12145,12805,11856,12178],0); -ELEMENTS[10800] = Fluid3D([12145,12805,12178,13158],0); -ELEMENTS[10801] = Fluid3D([13188,13231,13683,14189],0); -ELEMENTS[10802] = Fluid3D([12385,12145,11856,11422],0); -ELEMENTS[10803] = Fluid3D([12385,12145,11422,12228],0); -ELEMENTS[10804] = Fluid3D([12145,11856,11422,11277],0); -ELEMENTS[10805] = Fluid3D([12145,11856,11277,12178],0); -ELEMENTS[10806] = Fluid3D([11422,12145,11277,11285],0); -ELEMENTS[10807] = Fluid3D([11856,12385,11422,11593],0); -ELEMENTS[10808] = Fluid3D([12385,11422,11593,11735],0); -ELEMENTS[10809] = Fluid3D([12385,11422,11735,12228],0); -ELEMENTS[10810] = Fluid3D([11422,11856,11593,10895],0); -ELEMENTS[10811] = Fluid3D([11422,11856,10895,11277],0); -ELEMENTS[10812] = Fluid3D([11856,11593,10895,11530],0); -ELEMENTS[10813] = Fluid3D([10895,11856,11530,11212],0); -ELEMENTS[10814] = Fluid3D([10895,11856,11212,11277],0); -ELEMENTS[10815] = Fluid3D([11856,11593,11530,12664],0); -ELEMENTS[10816] = Fluid3D([11593,11530,12664,11777],0); -ELEMENTS[10817] = Fluid3D([11593,11530,11777,10964],0); -ELEMENTS[10818] = Fluid3D([11593,11530,10964,10895],0); -ELEMENTS[10819] = Fluid3D([11856,11593,12664,12385],0); -ELEMENTS[10820] = Fluid3D([12076,12766,12908,12104],0); -ELEMENTS[10821] = Fluid3D([12076,12766,12104,11866],0); -ELEMENTS[10822] = Fluid3D([12908,12076,12104,11946],0); -ELEMENTS[10823] = Fluid3D([12104,12908,11946,12769],0); -ELEMENTS[10824] = Fluid3D([11946,12104,12769,11892],0); -ELEMENTS[10825] = Fluid3D([11946,12104,11892,11374],0); -ELEMENTS[10826] = Fluid3D([11946,12104,11374,12076],0); -ELEMENTS[10827] = Fluid3D([12104,12769,11892,12499],0); -ELEMENTS[10828] = Fluid3D([12104,12769,12499,12766],0); -ELEMENTS[10829] = Fluid3D([11892,12104,12499,11575],0); -ELEMENTS[10830] = Fluid3D([11892,12104,11575,11374],0); -ELEMENTS[10831] = Fluid3D([12104,11575,11374,11866],0); -ELEMENTS[10832] = Fluid3D([12104,11374,12076,11866],0); -ELEMENTS[10833] = Fluid3D([12104,12499,11575,11866],0); -ELEMENTS[10834] = Fluid3D([12769,11946,11892,12112],0); -ELEMENTS[10835] = Fluid3D([12499,11892,11575,12077],0); -ELEMENTS[10836] = Fluid3D([11892,11575,12077,11037],0); -ELEMENTS[10837] = Fluid3D([11892,11575,11037,11084],0); -ELEMENTS[10838] = Fluid3D([11037,11892,11084,11392],0); -ELEMENTS[10839] = Fluid3D([11892,11084,11392,12112],0); -ELEMENTS[10840] = Fluid3D([11084,11037,11392,10381],0); -ELEMENTS[10841] = Fluid3D([11392,11084,10381,10313],0); -ELEMENTS[10842] = Fluid3D([11084,11037,10381,10262],0); -ELEMENTS[10843] = Fluid3D([10381,11084,10262,10153],0); -ELEMENTS[10844] = Fluid3D([10381,11084,10153,10313],0); -ELEMENTS[10845] = Fluid3D([12499,11892,12077,12696],0); -ELEMENTS[10846] = Fluid3D([12077,11892,11037,11392],0); -ELEMENTS[10847] = Fluid3D([12499,11892,12696,12769],0); -ELEMENTS[10848] = Fluid3D([11892,12077,12696,11392],0); -ELEMENTS[10849] = Fluid3D([11084,11037,10262,11575],0); -ELEMENTS[10850] = Fluid3D([11084,10262,10153,10278],0); -ELEMENTS[10851] = Fluid3D([10262,10153,10278,9403],0); -ELEMENTS[10852] = Fluid3D([10278,10262,9403,9960],0); -ELEMENTS[10853] = Fluid3D([10278,10262,9960,11374],0); -ELEMENTS[10854] = Fluid3D([10153,10278,9403,9707],0); -ELEMENTS[10855] = Fluid3D([10153,10278,9707,10771],0); -ELEMENTS[10856] = Fluid3D([11084,10262,10278,11374],0); -ELEMENTS[10857] = Fluid3D([9403,10278,9960,9577],0); -ELEMENTS[10858] = Fluid3D([10278,9403,9707,9577],0); -ELEMENTS[10859] = Fluid3D([9707,10278,9577,10454],0); -ELEMENTS[10860] = Fluid3D([9403,9707,9577,8801],0); -ELEMENTS[10861] = Fluid3D([9707,9577,8801,9647],0); -ELEMENTS[10862] = Fluid3D([9707,9577,9647,10454],0); -ELEMENTS[10863] = Fluid3D([10278,9960,9577,10454],0); -ELEMENTS[10864] = Fluid3D([10262,9403,9960,9434],0); -ELEMENTS[10865] = Fluid3D([9960,10262,9434,10440],0); -ELEMENTS[10866] = Fluid3D([9960,10262,10440,11374],0); -ELEMENTS[10867] = Fluid3D([9577,8801,9647,8774],0); -ELEMENTS[10868] = Fluid3D([10153,11084,10278,10771],0); -ELEMENTS[10869] = Fluid3D([9647,9577,8774,9659],0); -ELEMENTS[10870] = Fluid3D([10262,9403,9434,9603],0); -ELEMENTS[10871] = Fluid3D([9647,9577,9659,10454],0); -ELEMENTS[10872] = Fluid3D([10262,9403,9603,10153],0); -ELEMENTS[10873] = Fluid3D([8801,9707,9647,9024],0); -ELEMENTS[10874] = Fluid3D([9707,9647,9024,10055],0); -ELEMENTS[10875] = Fluid3D([9707,9647,10055,10454],0); -ELEMENTS[10876] = Fluid3D([9577,8801,8774,8832],0); -ELEMENTS[10877] = Fluid3D([9577,8801,8832,9403],0); -ELEMENTS[10878] = Fluid3D([8801,9707,9024,9093],0); -ELEMENTS[10879] = Fluid3D([8801,9707,9093,9403],0); -ELEMENTS[10880] = Fluid3D([9403,10153,9707,9093],0); -ELEMENTS[10881] = Fluid3D([10262,9434,10440,10187],0); -ELEMENTS[10882] = Fluid3D([9434,10262,9603,10187],0); -ELEMENTS[10883] = Fluid3D([8774,9577,8832,9352],0); -ELEMENTS[10884] = Fluid3D([8774,9577,9352,9659],0); -ELEMENTS[10885] = Fluid3D([9024,9707,10055,9834],0); -ELEMENTS[10886] = Fluid3D([9024,9707,9834,9093],0); -ELEMENTS[10887] = Fluid3D([10440,10262,10187,11037],0); -ELEMENTS[10888] = Fluid3D([10262,10187,11037,10381],0); -ELEMENTS[10889] = Fluid3D([9960,9403,9577,8832],0); -ELEMENTS[10890] = Fluid3D([9577,8832,9352,9960],0); -ELEMENTS[10891] = Fluid3D([9647,9024,10055,9102],0); -ELEMENTS[10892] = Fluid3D([10055,9647,9102,9860],0); -ELEMENTS[10893] = Fluid3D([8801,9647,8774,8329],0); -ELEMENTS[10894] = Fluid3D([9647,8774,8329,8808],0); -ELEMENTS[10895] = Fluid3D([9647,8774,8808,9659],0); -ELEMENTS[10896] = Fluid3D([9647,9102,9860,8808],0); -ELEMENTS[10897] = Fluid3D([10055,9647,9860,10370],0); -ELEMENTS[10898] = Fluid3D([10055,9647,10370,10454],0); -ELEMENTS[10899] = Fluid3D([9647,9860,10370,9659],0); -ELEMENTS[10900] = Fluid3D([9860,10055,10370,11188],0); -ELEMENTS[10901] = Fluid3D([9647,9024,9102,8329],0); -ELEMENTS[10902] = Fluid3D([9403,9960,9434,8832],0); -ELEMENTS[10903] = Fluid3D([9024,8801,9093,8219],0); -ELEMENTS[10904] = Fluid3D([8801,9093,8219,8406],0); -ELEMENTS[10905] = Fluid3D([8801,9093,8406,9403],0); -ELEMENTS[10906] = Fluid3D([9024,8801,8219,8329],0); -ELEMENTS[10907] = Fluid3D([9093,8219,8406,8365],0); -ELEMENTS[10908] = Fluid3D([8406,9093,8365,9011],0); -ELEMENTS[10909] = Fluid3D([8406,9093,9011,9403],0); -ELEMENTS[10910] = Fluid3D([8774,8801,8329,8007],0); -ELEMENTS[10911] = Fluid3D([8774,8801,8007,8832],0); -ELEMENTS[10912] = Fluid3D([8329,8774,8007,7871],0); -ELEMENTS[10913] = Fluid3D([8329,8774,7871,8808],0); -ELEMENTS[10914] = Fluid3D([8219,8801,8406,8007],0); -ELEMENTS[10915] = Fluid3D([9707,10055,9834,10771],0); -ELEMENTS[10916] = Fluid3D([9403,9434,9603,8699],0); -ELEMENTS[10917] = Fluid3D([9403,9434,8699,8832],0); -ELEMENTS[10918] = Fluid3D([9434,9603,8699,9091],0); -ELEMENTS[10919] = Fluid3D([9603,9403,8699,9011],0); -ELEMENTS[10920] = Fluid3D([8699,9603,9011,9091],0); -ELEMENTS[10921] = Fluid3D([9603,9403,9011,10153],0); -ELEMENTS[10922] = Fluid3D([11575,12077,11037,11120],0); -ELEMENTS[10923] = Fluid3D([11037,11575,11120,10440],0); -ELEMENTS[10924] = Fluid3D([11575,12077,11120,12059],0); -ELEMENTS[10925] = Fluid3D([11575,12077,12059,12499],0); -ELEMENTS[10926] = Fluid3D([9102,10055,9860,9963],0); -ELEMENTS[10927] = Fluid3D([10055,9860,9963,10757],0); -ELEMENTS[10928] = Fluid3D([10055,9860,10757,11188],0); -ELEMENTS[10929] = Fluid3D([8832,8774,9352,8411],0); -ELEMENTS[10930] = Fluid3D([8774,9352,8411,8863],0); -ELEMENTS[10931] = Fluid3D([8774,9352,8863,9659],0); -ELEMENTS[10932] = Fluid3D([9434,9960,10440,9566],0); -ELEMENTS[10933] = Fluid3D([9960,10440,9566,10351],0); -ELEMENTS[10934] = Fluid3D([9434,9960,9566,8832],0); -ELEMENTS[10935] = Fluid3D([9566,9960,10351,9352],0); -ELEMENTS[10936] = Fluid3D([10440,9434,9566,9648],0); -ELEMENTS[10937] = Fluid3D([9566,10440,9648,10199],0); -ELEMENTS[10938] = Fluid3D([9566,10440,10199,10351],0); -ELEMENTS[10939] = Fluid3D([9960,10440,10351,10749],0); -ELEMENTS[10940] = Fluid3D([9960,10440,10749,11374],0); -ELEMENTS[10941] = Fluid3D([10440,10351,10749,11196],0); -ELEMENTS[10942] = Fluid3D([10440,10351,11196,10199],0); -ELEMENTS[10943] = Fluid3D([10351,9960,10749,10541],0); -ELEMENTS[10944] = Fluid3D([10351,9960,10541,9352],0); -ELEMENTS[10945] = Fluid3D([9960,10749,10541,10454],0); -ELEMENTS[10946] = Fluid3D([10749,10440,11196,11575],0); -ELEMENTS[10947] = Fluid3D([11196,10749,11575,11866],0); -ELEMENTS[10948] = Fluid3D([9434,10440,10187,9648],0); -ELEMENTS[10949] = Fluid3D([9647,8801,9024,8329],0); -ELEMENTS[10950] = Fluid3D([10055,9024,9834,9616],0); -ELEMENTS[10951] = Fluid3D([9024,9834,9616,8852],0); -ELEMENTS[10952] = Fluid3D([9024,9834,8852,9093],0); -ELEMENTS[10953] = Fluid3D([9024,10055,9102,9616],0); -ELEMENTS[10954] = Fluid3D([10440,9648,10199,11120],0); -ELEMENTS[10955] = Fluid3D([12766,12908,12104,12769],0); -ELEMENTS[10956] = Fluid3D([9102,10055,9963,9616],0); -ELEMENTS[10957] = Fluid3D([13231,12805,13683,13532],0); -ELEMENTS[10958] = Fluid3D([12805,13683,13532,13470],0); -ELEMENTS[10959] = Fluid3D([13231,12805,13532,12664],0); -ELEMENTS[10960] = Fluid3D([13683,13231,13532,14189],0); -ELEMENTS[10961] = Fluid3D([12385,12805,13231,12664],0); -ELEMENTS[10962] = Fluid3D([12145,12228,11285,11422],0); -ELEMENTS[10963] = Fluid3D([13057,12997,12829,14021],0); -ELEMENTS[10964] = Fluid3D([12829,12997,12412,13516],0); -ELEMENTS[10965] = Fluid3D([12443,12829,12766,13352],0); -ELEMENTS[10966] = Fluid3D([12829,12766,13352,13606],0); -ELEMENTS[10967] = Fluid3D([12766,13352,13606,13544],0); -ELEMENTS[10968] = Fluid3D([13606,12766,13544,13273],0); -ELEMENTS[10969] = Fluid3D([13606,12766,13273,12908],0); -ELEMENTS[10970] = Fluid3D([12766,12443,13352,12762],0); -ELEMENTS[10971] = Fluid3D([12766,12443,12762,11866],0); -ELEMENTS[10972] = Fluid3D([12443,13352,12762,12963],0); -ELEMENTS[10973] = Fluid3D([13352,12762,12963,13979],0); -ELEMENTS[10974] = Fluid3D([12443,13352,12963,13057],0); -ELEMENTS[10975] = Fluid3D([12443,12829,13352,13057],0); -ELEMENTS[10976] = Fluid3D([12829,12766,13606,12908],0); -ELEMENTS[10977] = Fluid3D([12766,13352,13544,12762],0); -ELEMENTS[10978] = Fluid3D([13544,13606,13273,14127],0); -ELEMENTS[10979] = Fluid3D([13606,13273,14127,13882],0); -ELEMENTS[10980] = Fluid3D([13544,13606,14127,14376],0); -ELEMENTS[10981] = Fluid3D([13273,13544,14127,13695],0); -ELEMENTS[10982] = Fluid3D([14127,13273,13695,13896],0); -ELEMENTS[10983] = Fluid3D([14127,13273,13896,13882],0); -ELEMENTS[10984] = Fluid3D([13273,13544,13695,12499],0); -ELEMENTS[10985] = Fluid3D([13695,14127,13896,14734],0); -ELEMENTS[10986] = Fluid3D([13273,13695,13896,12926],0); -ELEMENTS[10987] = Fluid3D([13273,13695,12926,12499],0); -ELEMENTS[10988] = Fluid3D([12926,13273,12499,12769],0); -ELEMENTS[10989] = Fluid3D([13273,12499,12769,12766],0); -ELEMENTS[10990] = Fluid3D([12499,12926,12769,12696],0); -ELEMENTS[10991] = Fluid3D([12499,12926,12696,12077],0); -ELEMENTS[10992] = Fluid3D([12926,12769,12696,13406],0); -ELEMENTS[10993] = Fluid3D([12696,12926,13406,13441],0); -ELEMENTS[10994] = Fluid3D([12696,12926,13441,12593],0); -ELEMENTS[10995] = Fluid3D([12696,12926,12593,12077],0); -ELEMENTS[10996] = Fluid3D([12593,12696,12077,12162],0); -ELEMENTS[10997] = Fluid3D([12077,12593,12162,11914],0); -ELEMENTS[10998] = Fluid3D([12077,12593,11914,12059],0); -ELEMENTS[10999] = Fluid3D([12926,13441,12593,13676],0); -ELEMENTS[11000] = Fluid3D([13441,12696,12593,12162],0); -ELEMENTS[11001] = Fluid3D([12926,13406,13441,13896],0); -ELEMENTS[11002] = Fluid3D([12926,13406,13896,12769],0); -ELEMENTS[11003] = Fluid3D([12593,12926,13676,12895],0); -ELEMENTS[11004] = Fluid3D([12593,12926,12895,12499],0); -ELEMENTS[11005] = Fluid3D([12926,12895,12499,13695],0); -ELEMENTS[11006] = Fluid3D([12593,12926,12499,12077],0); -ELEMENTS[11007] = Fluid3D([12926,13441,13676,13896],0); -ELEMENTS[11008] = Fluid3D([13406,12696,13441,13316],0); -ELEMENTS[11009] = Fluid3D([12593,12162,11914,12947],0); -ELEMENTS[11010] = Fluid3D([12926,13273,12769,13896],0); -ELEMENTS[11011] = Fluid3D([12926,13676,12895,13695],0); -ELEMENTS[11012] = Fluid3D([12926,13676,13695,13896],0); -ELEMENTS[11013] = Fluid3D([12162,12077,11914,11203],0); -ELEMENTS[11014] = Fluid3D([12077,11914,11203,11120],0); -ELEMENTS[11015] = Fluid3D([13676,12895,13695,13867],0); -ELEMENTS[11016] = Fluid3D([12162,12077,11203,11392],0); -ELEMENTS[11017] = Fluid3D([13676,12593,12895,12856],0); -ELEMENTS[11018] = Fluid3D([12593,12895,12856,12059],0); -ELEMENTS[11019] = Fluid3D([12696,12077,12162,11392],0); -ELEMENTS[11020] = Fluid3D([13441,12593,13676,13458],0); -ELEMENTS[11021] = Fluid3D([13676,12593,12856,13458],0); -ELEMENTS[11022] = Fluid3D([13676,13441,13458,14002],0); -ELEMENTS[11023] = Fluid3D([13676,13441,14002,13896],0); -ELEMENTS[11024] = Fluid3D([13458,13676,14002,13843],0); -ELEMENTS[11025] = Fluid3D([11914,12162,11203,11714],0); -ELEMENTS[11026] = Fluid3D([12895,13676,12856,13867],0); -ELEMENTS[11027] = Fluid3D([13441,13458,14002,13819],0); -ELEMENTS[11028] = Fluid3D([13441,12593,13458,12162],0); -ELEMENTS[11029] = Fluid3D([13544,14127,13695,14314],0); -ELEMENTS[11030] = Fluid3D([14127,13695,14314,14734],0); -ELEMENTS[11031] = Fluid3D([13695,13544,14314,13908],0); -ELEMENTS[11032] = Fluid3D([13352,12829,13606,14021],0); -ELEMENTS[11033] = Fluid3D([12766,13544,13273,12499],0); -ELEMENTS[11034] = Fluid3D([13352,13606,13544,14376],0); -ELEMENTS[11035] = Fluid3D([11305,12255,11489,11320],0); -ELEMENTS[11036] = Fluid3D([11305,12255,11320,12112],0); -ELEMENTS[11037] = Fluid3D([11489,11305,11320,10458],0); -ELEMENTS[11038] = Fluid3D([10771,10454,10278,9707],0); -ELEMENTS[11039] = Fluid3D([13954,13489,13464,12881],0); -ELEMENTS[11040] = Fluid3D([12940,13542,13783,14049],0); -ELEMENTS[11041] = Fluid3D([13967,13753,14446,13250],0); -ELEMENTS[11042] = Fluid3D([13472,13942,13047,13432],0); -ELEMENTS[11043] = Fluid3D([14454,14420,14176,15186],0); -ELEMENTS[11044] = Fluid3D([15033,14401,15121,14574],0); -ELEMENTS[11045] = Fluid3D([15021,14407,15140,15064],0); -ELEMENTS[11046] = Fluid3D([14079,14108,13858,14634],0); -ELEMENTS[11047] = Fluid3D([13858,14079,14634,14096],0); -ELEMENTS[11048] = Fluid3D([14079,14108,14634,14754],0); -ELEMENTS[11049] = Fluid3D([14079,14634,14096,14606],0); -ELEMENTS[11050] = Fluid3D([14634,14096,14606,14900],0); -ELEMENTS[11051] = Fluid3D([14108,14634,14754,15025],0); -ELEMENTS[11052] = Fluid3D([14634,14096,14900,14479],0); -ELEMENTS[11053] = Fluid3D([14096,14900,14479,14370],0); -ELEMENTS[11054] = Fluid3D([14096,14900,14370,14435],0); -ELEMENTS[11055] = Fluid3D([14096,14900,14435,14606],0); -ELEMENTS[11056] = Fluid3D([14634,14096,14479,13858],0); -ELEMENTS[11057] = Fluid3D([14108,14634,15025,14589],0); -ELEMENTS[11058] = Fluid3D([15025,14108,14589,14638],0); -ELEMENTS[11059] = Fluid3D([15025,14108,14638,14545],0); -ELEMENTS[11060] = Fluid3D([14634,15025,14589,15207],0); -ELEMENTS[11061] = Fluid3D([14108,14634,14589,13858],0); -ELEMENTS[11062] = Fluid3D([14079,14108,14754,14537],0); -ELEMENTS[11063] = Fluid3D([14079,14634,14606,14754],0); -ELEMENTS[11064] = Fluid3D([14900,14370,14435,15142],0); -ELEMENTS[11065] = Fluid3D([14900,14370,15142,14479],0); -ELEMENTS[11066] = Fluid3D([14589,15025,14638,15266],0); -ELEMENTS[11067] = Fluid3D([14096,14079,14606,13817],0); -ELEMENTS[11068] = Fluid3D([14096,14079,13817,12894],0); -ELEMENTS[11069] = Fluid3D([14079,14606,13817,14550],0); -ELEMENTS[11070] = Fluid3D([14606,13817,14550,14562],0); -ELEMENTS[11071] = Fluid3D([14550,14606,14562,15433],0); -ELEMENTS[11072] = Fluid3D([14079,14606,14550,14754],0); -ELEMENTS[11073] = Fluid3D([14606,14550,14754,15393],0); -ELEMENTS[11074] = Fluid3D([14606,13817,14562,14435],0); -ELEMENTS[11075] = Fluid3D([14562,14606,14435,15433],0); -ELEMENTS[11076] = Fluid3D([14606,14096,13817,14435],0); -ELEMENTS[11077] = Fluid3D([14108,14589,14638,13898],0); -ELEMENTS[11078] = Fluid3D([14589,14638,13898,14526],0); -ELEMENTS[11079] = Fluid3D([14638,13898,14526,14062],0); -ELEMENTS[11080] = Fluid3D([13898,14526,14062,13742],0); -ELEMENTS[11081] = Fluid3D([13898,14526,13742,13993],0); -ELEMENTS[11082] = Fluid3D([14526,13742,13993,14215],0); -ELEMENTS[11083] = Fluid3D([14526,13742,14215,14382],0); -ELEMENTS[11084] = Fluid3D([14526,13742,14382,14062],0); -ELEMENTS[11085] = Fluid3D([13898,14526,13993,14589],0); -ELEMENTS[11086] = Fluid3D([14108,14589,13898,13858],0); -ELEMENTS[11087] = Fluid3D([14638,13898,14062,13704],0); -ELEMENTS[11088] = Fluid3D([13742,13993,14215,13467],0); -ELEMENTS[11089] = Fluid3D([13742,13993,13467,13145],0); -ELEMENTS[11090] = Fluid3D([13467,13742,13145,12879],0); -ELEMENTS[11091] = Fluid3D([13467,13742,12879,13711],0); -ELEMENTS[11092] = Fluid3D([13742,12879,13711,13297],0); -ELEMENTS[11093] = Fluid3D([13742,12879,13297,13046],0); -ELEMENTS[11094] = Fluid3D([13742,12879,13046,13145],0); -ELEMENTS[11095] = Fluid3D([13993,14215,13467,14385],0); -ELEMENTS[11096] = Fluid3D([13467,13742,13711,14215],0); -ELEMENTS[11097] = Fluid3D([13742,13993,13145,13898],0); -ELEMENTS[11098] = Fluid3D([13993,13467,13145,13346],0); -ELEMENTS[11099] = Fluid3D([13145,13993,13346,13858],0); -ELEMENTS[11100] = Fluid3D([13467,13145,13346,12582],0); -ELEMENTS[11101] = Fluid3D([13145,13346,12582,12603],0); -ELEMENTS[11102] = Fluid3D([13145,13346,12603,13858],0); -ELEMENTS[11103] = Fluid3D([13346,12582,12603,12570],0); -ELEMENTS[11104] = Fluid3D([13346,12582,12570,13090],0); -ELEMENTS[11105] = Fluid3D([12582,12570,13090,12256],0); -ELEMENTS[11106] = Fluid3D([12582,12603,12570,11787],0); -ELEMENTS[11107] = Fluid3D([12582,12603,11787,12099],0); -ELEMENTS[11108] = Fluid3D([12582,12603,12099,13145],0); -ELEMENTS[11109] = Fluid3D([13993,13467,13346,14385],0); -ELEMENTS[11110] = Fluid3D([12582,12570,12256,11787],0); -ELEMENTS[11111] = Fluid3D([13346,12582,13090,13467],0); -ELEMENTS[11112] = Fluid3D([13467,13145,12582,12879],0); -ELEMENTS[11113] = Fluid3D([14638,14108,13898,13704],0); -ELEMENTS[11114] = Fluid3D([12603,13346,12570,13096],0); -ELEMENTS[11115] = Fluid3D([12603,13346,13096,13858],0); -ELEMENTS[11116] = Fluid3D([13346,12570,13096,13409],0); -ELEMENTS[11117] = Fluid3D([13096,13346,13409,13961],0); -ELEMENTS[11118] = Fluid3D([13096,13346,13961,13858],0); -ELEMENTS[11119] = Fluid3D([13409,13096,13961,13646],0); -ELEMENTS[11120] = Fluid3D([13096,13961,13646,13756],0); -ELEMENTS[11121] = Fluid3D([13096,13961,13756,13858],0); -ELEMENTS[11122] = Fluid3D([13409,13096,13646,12782],0); -ELEMENTS[11123] = Fluid3D([13409,13096,12782,12570],0); -ELEMENTS[11124] = Fluid3D([13646,13409,12782,13865],0); -ELEMENTS[11125] = Fluid3D([13346,12570,13409,13090],0); -ELEMENTS[11126] = Fluid3D([13096,13646,12782,12959],0); -ELEMENTS[11127] = Fluid3D([13096,13646,12959,13756],0); -ELEMENTS[11128] = Fluid3D([13646,12782,12959,13278],0); -ELEMENTS[11129] = Fluid3D([12782,13096,12959,12204],0); -ELEMENTS[11130] = Fluid3D([12782,13096,12204,12570],0); -ELEMENTS[11131] = Fluid3D([13096,12959,12204,12503],0); -ELEMENTS[11132] = Fluid3D([13096,12959,12503,13756],0); -ELEMENTS[11133] = Fluid3D([12959,12782,12204,12189],0); -ELEMENTS[11134] = Fluid3D([12959,12782,12189,13278],0); -ELEMENTS[11135] = Fluid3D([12782,12204,12189,11814],0); -ELEMENTS[11136] = Fluid3D([12782,12204,11814,12570],0); -ELEMENTS[11137] = Fluid3D([12204,12189,11814,11461],0); -ELEMENTS[11138] = Fluid3D([12189,11814,11461,11128],0); -ELEMENTS[11139] = Fluid3D([11814,12204,11461,11381],0); -ELEMENTS[11140] = Fluid3D([12204,12189,11461,12252],0); -ELEMENTS[11141] = Fluid3D([12204,11461,11381,11580],0); -ELEMENTS[11142] = Fluid3D([12204,11461,11580,12252],0); -ELEMENTS[11143] = Fluid3D([12204,12189,12252,12959],0); -ELEMENTS[11144] = Fluid3D([11814,12204,11381,12570],0); -ELEMENTS[11145] = Fluid3D([12959,12204,12503,12252],0); -ELEMENTS[11146] = Fluid3D([13346,13409,13961,14385],0); -ELEMENTS[11147] = Fluid3D([13961,13646,13756,14763],0); -ELEMENTS[11148] = Fluid3D([12204,13096,12503,12603],0); -ELEMENTS[11149] = Fluid3D([12570,12603,13096,12204],0); -ELEMENTS[11150] = Fluid3D([13961,13409,13646,14328],0); -ELEMENTS[11151] = Fluid3D([13961,13409,14328,14385],0); -ELEMENTS[11152] = Fluid3D([14526,14638,14062,14940],0); -ELEMENTS[11153] = Fluid3D([14638,14062,14940,14628],0); -ELEMENTS[11154] = Fluid3D([14062,14940,14628,14676],0); -ELEMENTS[11155] = Fluid3D([14628,14062,14676,13876],0); -ELEMENTS[11156] = Fluid3D([14628,14062,13876,13704],0); -ELEMENTS[11157] = Fluid3D([14526,14638,14940,15266],0); -ELEMENTS[11158] = Fluid3D([14940,14526,15266,14911],0); -ELEMENTS[11159] = Fluid3D([14062,14526,14940,14382],0); -ELEMENTS[11160] = Fluid3D([14638,14062,14628,13704],0); -ELEMENTS[11161] = Fluid3D([14940,14638,14628,15279],0); -ELEMENTS[11162] = Fluid3D([14638,14628,15279,14781],0); -ELEMENTS[11163] = Fluid3D([14940,14638,15279,15266],0); -ELEMENTS[11164] = Fluid3D([14628,15279,14781,15299],0); -ELEMENTS[11165] = Fluid3D([14628,15279,15299,15271],0); -ELEMENTS[11166] = Fluid3D([15279,14781,15299,15480],0); -ELEMENTS[11167] = Fluid3D([15279,15299,15271,16042],0); -ELEMENTS[11168] = Fluid3D([14628,14940,15279,15271],0); -ELEMENTS[11169] = Fluid3D([15279,14781,15480,15025],0); -ELEMENTS[11170] = Fluid3D([14638,14628,14781,13704],0); -ELEMENTS[11171] = Fluid3D([15279,14638,14781,15025],0); -ELEMENTS[11172] = Fluid3D([14676,14628,13876,14285],0); -ELEMENTS[11173] = Fluid3D([14062,14940,14676,14382],0); -ELEMENTS[11174] = Fluid3D([14781,14628,15299,14373],0); -ELEMENTS[11175] = Fluid3D([14781,14628,14373,13704],0); -ELEMENTS[11176] = Fluid3D([14628,15299,14373,14826],0); -ELEMENTS[11177] = Fluid3D([14628,15299,14826,15271],0); -ELEMENTS[11178] = Fluid3D([14373,14628,14826,14285],0); -ELEMENTS[11179] = Fluid3D([15299,14781,14373,15140],0); -ELEMENTS[11180] = Fluid3D([15299,14373,14826,14830],0); -ELEMENTS[11181] = Fluid3D([14373,14826,14830,14151],0); -ELEMENTS[11182] = Fluid3D([15299,14373,14830,15140],0); -ELEMENTS[11183] = Fluid3D([14826,15299,14830,15412],0); -ELEMENTS[11184] = Fluid3D([14830,14373,14151,14359],0); -ELEMENTS[11185] = Fluid3D([14830,14373,14359,15140],0); -ELEMENTS[11186] = Fluid3D([14830,14826,15412,14414],0); -ELEMENTS[11187] = Fluid3D([15299,14830,15412,15464],0); -ELEMENTS[11188] = Fluid3D([14373,14151,14359,13558],0); -ELEMENTS[11189] = Fluid3D([15299,14830,15464,15140],0); -ELEMENTS[11190] = Fluid3D([14830,15412,15464,15261],0); -ELEMENTS[11191] = Fluid3D([14830,15412,15261,14414],0); -ELEMENTS[11192] = Fluid3D([15464,14830,15261,15064],0); -ELEMENTS[11193] = Fluid3D([15412,15299,15464,15846],0); -ELEMENTS[11194] = Fluid3D([15299,15464,15846,15480],0); -ELEMENTS[11195] = Fluid3D([14826,15299,15412,15271],0); -ELEMENTS[11196] = Fluid3D([15464,14830,15064,15140],0); -ELEMENTS[11197] = Fluid3D([15064,15464,15140,15653],0); -ELEMENTS[11198] = Fluid3D([15064,15464,15653,15647],0); -ELEMENTS[11199] = Fluid3D([15064,15464,15647,15261],0); -ELEMENTS[11200] = Fluid3D([15464,15647,15261,15845],0); -ELEMENTS[11201] = Fluid3D([15647,15261,15845,15739],0); -ELEMENTS[11202] = Fluid3D([15647,15261,15739,14934],0); -ELEMENTS[11203] = Fluid3D([15464,15647,15845,16067],0); -ELEMENTS[11204] = Fluid3D([15845,15647,15739,16336],0); -ELEMENTS[11205] = Fluid3D([15464,15653,15647,16067],0); -ELEMENTS[11206] = Fluid3D([15464,15653,16067,15816],0); -ELEMENTS[11207] = Fluid3D([15653,16067,15816,16194],0); -ELEMENTS[11208] = Fluid3D([15653,16067,16194,15900],0); -ELEMENTS[11209] = Fluid3D([15653,15647,16067,15900],0); -ELEMENTS[11210] = Fluid3D([15816,15653,16194,15565],0); -ELEMENTS[11211] = Fluid3D([16067,15816,16194,16346],0); -ELEMENTS[11212] = Fluid3D([15464,15653,15816,15140],0); -ELEMENTS[11213] = Fluid3D([15647,15845,16067,16336],0); -ELEMENTS[11214] = Fluid3D([15653,15064,15647,15579],0); -ELEMENTS[11215] = Fluid3D([15261,15845,15739,15592],0); -ELEMENTS[11216] = Fluid3D([15647,15739,16336,15882],0); -ELEMENTS[11217] = Fluid3D([15647,15739,15882,14934],0); -ELEMENTS[11218] = Fluid3D([15412,15464,15261,15845],0); -ELEMENTS[11219] = Fluid3D([15739,15845,16336,16237],0); -ELEMENTS[11220] = Fluid3D([15261,15845,15592,15412],0); -ELEMENTS[11221] = Fluid3D([16336,15647,15882,16108],0); -ELEMENTS[11222] = Fluid3D([16336,15647,16108,16067],0); -ELEMENTS[11223] = Fluid3D([15647,15882,16108,15579],0); -ELEMENTS[11224] = Fluid3D([15882,16108,15579,16363],0); -ELEMENTS[11225] = Fluid3D([15647,15882,15579,14934],0); -ELEMENTS[11226] = Fluid3D([16108,15647,15579,15900],0); -ELEMENTS[11227] = Fluid3D([15579,16108,15900,15841],0); -ELEMENTS[11228] = Fluid3D([15464,15412,15846,15845],0); -ELEMENTS[11229] = Fluid3D([16067,15464,15816,15846],0); -ELEMENTS[11230] = Fluid3D([15412,15299,15846,16042],0); -ELEMENTS[11231] = Fluid3D([15739,16336,15882,16199],0); -ELEMENTS[11232] = Fluid3D([15882,15739,16199,15673],0); -ELEMENTS[11233] = Fluid3D([15882,15739,15673,15370],0); -ELEMENTS[11234] = Fluid3D([15673,15882,15370,15943],0); -ELEMENTS[11235] = Fluid3D([15370,15673,15943,15488],0); -ELEMENTS[11236] = Fluid3D([15882,15370,15943,15579],0); -ELEMENTS[11237] = Fluid3D([15882,15370,15579,14934],0); -ELEMENTS[11238] = Fluid3D([15673,15882,15943,16199],0); -ELEMENTS[11239] = Fluid3D([15739,15261,15592,15305],0); -ELEMENTS[11240] = Fluid3D([15845,15739,15592,16237],0); -ELEMENTS[11241] = Fluid3D([15739,16336,16199,16237],0); -ELEMENTS[11242] = Fluid3D([15140,15064,15653,15021],0); -ELEMENTS[11243] = Fluid3D([15845,15464,16067,15846],0); -ELEMENTS[11244] = Fluid3D([15882,16336,16108,16363],0); -ELEMENTS[11245] = Fluid3D([16336,15882,16199,16363],0); -ELEMENTS[11246] = Fluid3D([15739,16199,15673,15906],0); -ELEMENTS[11247] = Fluid3D([15739,16199,15906,16237],0); -ELEMENTS[11248] = Fluid3D([15673,15739,15906,15305],0); -ELEMENTS[11249] = Fluid3D([16199,15673,15906,16275],0); -ELEMENTS[11250] = Fluid3D([14062,14676,13876,13767],0); -ELEMENTS[11251] = Fluid3D([13876,14062,13767,13046],0); -ELEMENTS[11252] = Fluid3D([14062,14676,13767,14382],0); -ELEMENTS[11253] = Fluid3D([14676,13876,13767,13960],0); -ELEMENTS[11254] = Fluid3D([13876,13767,13960,13141],0); -ELEMENTS[11255] = Fluid3D([13767,13960,13141,13336],0); -ELEMENTS[11256] = Fluid3D([13960,13141,13336,13527],0); -ELEMENTS[11257] = Fluid3D([13767,14676,13960,14271],0); -ELEMENTS[11258] = Fluid3D([14676,13960,14271,14903],0); -ELEMENTS[11259] = Fluid3D([14676,13960,14903,14285],0); -ELEMENTS[11260] = Fluid3D([13767,14676,14271,14382],0); -ELEMENTS[11261] = Fluid3D([14676,13876,13960,14285],0); -ELEMENTS[11262] = Fluid3D([13876,13767,13141,13046],0); -ELEMENTS[11263] = Fluid3D([13767,13960,13336,14271],0); -ELEMENTS[11264] = Fluid3D([13960,13876,13141,13374],0); -ELEMENTS[11265] = Fluid3D([13141,13767,13336,13297],0); -ELEMENTS[11266] = Fluid3D([13767,13336,13297,14271],0); -ELEMENTS[11267] = Fluid3D([13960,14271,14903,14168],0); -ELEMENTS[11268] = Fluid3D([13960,14271,14168,13336],0); -ELEMENTS[11269] = Fluid3D([14271,14903,14168,14810],0); -ELEMENTS[11270] = Fluid3D([14168,14271,14810,14162],0); -ELEMENTS[11271] = Fluid3D([14168,14271,14162,13336],0); -ELEMENTS[11272] = Fluid3D([14810,14168,14162,14441],0); -ELEMENTS[11273] = Fluid3D([14168,14162,14441,13604],0); -ELEMENTS[11274] = Fluid3D([14168,14162,13604,13336],0); -ELEMENTS[11275] = Fluid3D([14810,14168,14441,14936],0); -ELEMENTS[11276] = Fluid3D([14168,14441,14936,14181],0); -ELEMENTS[11277] = Fluid3D([14441,14936,14181,14834],0); -ELEMENTS[11278] = Fluid3D([14441,14936,14834,15206],0); -ELEMENTS[11279] = Fluid3D([14271,14903,14810,15418],0); -ELEMENTS[11280] = Fluid3D([14168,14441,14181,13604],0); -ELEMENTS[11281] = Fluid3D([14810,14168,14936,14903],0); -ELEMENTS[11282] = Fluid3D([14271,14810,14162,14566],0); -ELEMENTS[11283] = Fluid3D([14271,14810,14566,15418],0); -ELEMENTS[11284] = Fluid3D([14162,14271,14566,13807],0); -ELEMENTS[11285] = Fluid3D([14162,14271,13807,13336],0); -ELEMENTS[11286] = Fluid3D([14566,14162,13807,14644],0); -ELEMENTS[11287] = Fluid3D([13807,14566,14644,14532],0); -ELEMENTS[11288] = Fluid3D([14810,14162,14566,15088],0); -ELEMENTS[11289] = Fluid3D([14566,14810,15088,15418],0); -ELEMENTS[11290] = Fluid3D([14810,15088,15418,15512],0); -ELEMENTS[11291] = Fluid3D([14810,15088,15512,15206],0); -ELEMENTS[11292] = Fluid3D([14271,14566,13807,14382],0); -ELEMENTS[11293] = Fluid3D([14162,14441,13604,13937],0); -ELEMENTS[11294] = Fluid3D([14162,14441,13937,14768],0); -ELEMENTS[11295] = Fluid3D([13604,14162,13937,13149],0); -ELEMENTS[11296] = Fluid3D([14162,13937,13149,13925],0); -ELEMENTS[11297] = Fluid3D([14162,13937,13925,14768],0); -ELEMENTS[11298] = Fluid3D([14441,13604,13937,13940],0); -ELEMENTS[11299] = Fluid3D([13604,13937,13940,13160],0); -ELEMENTS[11300] = Fluid3D([13937,13149,13925,13334],0); -ELEMENTS[11301] = Fluid3D([13937,13149,13334,13160],0); -ELEMENTS[11302] = Fluid3D([13937,13940,13160,13785],0); -ELEMENTS[11303] = Fluid3D([13940,13160,13785,13313],0); -ELEMENTS[11304] = Fluid3D([13940,13160,13313,13175],0); -ELEMENTS[11305] = Fluid3D([13940,13160,13175,13604],0); -ELEMENTS[11306] = Fluid3D([13937,13940,13785,14553],0); -ELEMENTS[11307] = Fluid3D([13937,13940,14553,14441],0); -ELEMENTS[11308] = Fluid3D([13785,13937,14553,14264],0); -ELEMENTS[11309] = Fluid3D([14553,13785,14264,14474],0); -ELEMENTS[11310] = Fluid3D([13785,13937,14264,13334],0); -ELEMENTS[11311] = Fluid3D([14553,13785,14474,14427],0); -ELEMENTS[11312] = Fluid3D([14553,13785,14427,13940],0); -ELEMENTS[11313] = Fluid3D([13785,14474,14427,14112],0); -ELEMENTS[11314] = Fluid3D([14427,13785,14112,13313],0); -ELEMENTS[11315] = Fluid3D([13785,14474,14112,13707],0); -ELEMENTS[11316] = Fluid3D([13785,14474,13707,14264],0); -ELEMENTS[11317] = Fluid3D([14474,14112,13707,14737],0); -ELEMENTS[11318] = Fluid3D([13604,13937,13160,13149],0); -ELEMENTS[11319] = Fluid3D([14441,13604,13940,14181],0); -ELEMENTS[11320] = Fluid3D([13604,14162,13149,13336],0); -ELEMENTS[11321] = Fluid3D([13149,14162,13925,13807],0); -ELEMENTS[11322] = Fluid3D([14903,13960,14168,14436],0); -ELEMENTS[11323] = Fluid3D([13960,14168,14436,13527],0); -ELEMENTS[11324] = Fluid3D([14436,13960,13527,14285],0); -ELEMENTS[11325] = Fluid3D([14903,13960,14436,14285],0); -ELEMENTS[11326] = Fluid3D([14168,14903,14436,14936],0); -ELEMENTS[11327] = Fluid3D([13937,14553,14264,14768],0); -ELEMENTS[11328] = Fluid3D([14162,14810,14441,14768],0); -ELEMENTS[11329] = Fluid3D([14940,14628,14676,15271],0); -ELEMENTS[11330] = Fluid3D([14589,14638,14526,15266],0); -ELEMENTS[11331] = Fluid3D([13858,14079,14096,12894],0); -ELEMENTS[11332] = Fluid3D([14634,14754,15025,15290],0); -ELEMENTS[11333] = Fluid3D([14634,14754,15290,14606],0); -ELEMENTS[11334] = Fluid3D([14754,15025,15290,15297],0); -ELEMENTS[11335] = Fluid3D([15025,14634,15290,15552],0); -ELEMENTS[11336] = Fluid3D([15290,15025,15552,15940],0); -ELEMENTS[11337] = Fluid3D([13993,14526,14215,14841],0); -ELEMENTS[11338] = Fluid3D([14526,14215,14841,14911],0); -ELEMENTS[11339] = Fluid3D([14215,14841,14911,14450],0); -ELEMENTS[11340] = Fluid3D([14215,14841,14450,14385],0); -ELEMENTS[11341] = Fluid3D([14911,14215,14450,14532],0); -ELEMENTS[11342] = Fluid3D([14450,14215,14385,13467],0); -ELEMENTS[11343] = Fluid3D([14450,14215,13467,13711],0); -ELEMENTS[11344] = Fluid3D([14215,13993,14841,14385],0); -ELEMENTS[11345] = Fluid3D([14450,14215,13711,14532],0); -ELEMENTS[11346] = Fluid3D([14062,13898,13742,13046],0); -ELEMENTS[11347] = Fluid3D([14606,14634,14900,15290],0); -ELEMENTS[11348] = Fluid3D([14754,14108,15025,14545],0); -ELEMENTS[11349] = Fluid3D([14900,14634,14479,15170],0); -ELEMENTS[11350] = Fluid3D([14479,14900,15170,15142],0); -ELEMENTS[11351] = Fluid3D([14900,15170,15142,15542],0); -ELEMENTS[11352] = Fluid3D([15142,14900,15542,15118],0); -ELEMENTS[11353] = Fluid3D([15142,14900,15118,14435],0); -ELEMENTS[11354] = Fluid3D([14900,15118,14435,15433],0); -ELEMENTS[11355] = Fluid3D([14900,15542,15118,15433],0); -ELEMENTS[11356] = Fluid3D([14370,14096,14435,13665],0); -ELEMENTS[11357] = Fluid3D([14096,14435,13665,13817],0); -ELEMENTS[11358] = Fluid3D([14435,14370,13665,14331],0); -ELEMENTS[11359] = Fluid3D([14370,14096,13665,13756],0); -ELEMENTS[11360] = Fluid3D([13665,14370,13756,13786],0); -ELEMENTS[11361] = Fluid3D([14370,13756,13786,13646],0); -ELEMENTS[11362] = Fluid3D([14370,14096,13756,14479],0); -ELEMENTS[11363] = Fluid3D([13756,13665,13786,12959],0); -ELEMENTS[11364] = Fluid3D([14096,13665,13756,12503],0); -ELEMENTS[11365] = Fluid3D([13756,14370,14479,14763],0); -ELEMENTS[11366] = Fluid3D([13756,13786,13646,12959],0); -ELEMENTS[11367] = Fluid3D([13786,13646,12959,13278],0); -ELEMENTS[11368] = Fluid3D([13665,14370,13786,14331],0); -ELEMENTS[11369] = Fluid3D([14454,13656,13997,14714],0); -ELEMENTS[11370] = Fluid3D([14454,13656,14714,14176],0); -ELEMENTS[11371] = Fluid3D([14714,14454,14176,15186],0); -ELEMENTS[11372] = Fluid3D([13656,14714,14176,13976],0); -ELEMENTS[11373] = Fluid3D([14714,14176,13976,14629],0); -ELEMENTS[11374] = Fluid3D([14714,14454,15186,15341],0); -ELEMENTS[11375] = Fluid3D([15186,14714,15341,15098],0); -ELEMENTS[11376] = Fluid3D([14176,14714,15186,14969],0); -ELEMENTS[11377] = Fluid3D([14176,14714,14969,15098],0); -ELEMENTS[11378] = Fluid3D([13656,14714,13976,13997],0); -ELEMENTS[11379] = Fluid3D([15341,15186,15098,15760],0); -ELEMENTS[11380] = Fluid3D([14176,14714,15098,14629],0); -ELEMENTS[11381] = Fluid3D([13976,14714,14629,14916],0); -ELEMENTS[11382] = Fluid3D([14176,13656,13976,13489],0); -ELEMENTS[11383] = Fluid3D([10509,10656,10048,9696],0); -ELEMENTS[11384] = Fluid3D([13742,14215,14382,13711],0); -ELEMENTS[11385] = Fluid3D([4589,4937,4477,4399],0); -ELEMENTS[11386] = Fluid3D([4477,4589,4399,4059],0); -ELEMENTS[11387] = Fluid3D([4589,4937,4399,4791],0); -ELEMENTS[11388] = Fluid3D([4589,4937,4791,5155],0); -ELEMENTS[11389] = Fluid3D([4589,4399,4059,4215],0); -ELEMENTS[11390] = Fluid3D([4589,4399,4215,4791],0); -ELEMENTS[11391] = Fluid3D([4937,4399,4791,4845],0); -ELEMENTS[11392] = Fluid3D([4937,4399,4845,4657],0); -ELEMENTS[11393] = Fluid3D([4399,4059,4215,3713],0); -ELEMENTS[11394] = Fluid3D([4399,4791,4845,4434],0); -ELEMENTS[11395] = Fluid3D([4791,4845,4434,4993],0); -ELEMENTS[11396] = Fluid3D([4399,4791,4434,4215],0); -ELEMENTS[11397] = Fluid3D([4845,4434,4993,4714],0); -ELEMENTS[11398] = Fluid3D([4845,4399,4434,4472],0); -ELEMENTS[11399] = Fluid3D([4434,4993,4714,4591],0); -ELEMENTS[11400] = Fluid3D([4993,4714,4591,5120],0); -ELEMENTS[11401] = Fluid3D([4993,4714,5120,5316],0); -ELEMENTS[11402] = Fluid3D([4993,4714,5316,4845],0); -ELEMENTS[11403] = Fluid3D([4434,4993,4591,4621],0); -ELEMENTS[11404] = Fluid3D([4993,4591,4621,5048],0); -ELEMENTS[11405] = Fluid3D([4993,4591,5048,5120],0); -ELEMENTS[11406] = Fluid3D([4434,4993,4621,4791],0); -ELEMENTS[11407] = Fluid3D([4591,4621,5048,4512],0); -ELEMENTS[11408] = Fluid3D([4591,4621,4512,4120],0); -ELEMENTS[11409] = Fluid3D([4591,4621,4120,4434],0); -ELEMENTS[11410] = Fluid3D([4621,4512,4120,4264],0); -ELEMENTS[11411] = Fluid3D([4120,4621,4264,4215],0); -ELEMENTS[11412] = Fluid3D([4621,5048,4512,4881],0); -ELEMENTS[11413] = Fluid3D([5048,4512,4881,4999],0); -ELEMENTS[11414] = Fluid3D([5048,4512,4999,4907],0); -ELEMENTS[11415] = Fluid3D([5048,4512,4907,4591],0); -ELEMENTS[11416] = Fluid3D([4621,4512,4264,4881],0); -ELEMENTS[11417] = Fluid3D([4621,5048,4881,5187],0); -ELEMENTS[11418] = Fluid3D([5048,4881,5187,5468],0); -ELEMENTS[11419] = Fluid3D([5048,4881,5468,4999],0); -ELEMENTS[11420] = Fluid3D([4621,5048,5187,4993],0); -ELEMENTS[11421] = Fluid3D([4881,4621,5187,4743],0); -ELEMENTS[11422] = Fluid3D([5187,4881,4743,5267],0); -ELEMENTS[11423] = Fluid3D([5187,4881,5267,5468],0); -ELEMENTS[11424] = Fluid3D([4881,4621,4743,4264],0); -ELEMENTS[11425] = Fluid3D([4621,5187,4743,4791],0); -ELEMENTS[11426] = Fluid3D([4791,4845,4993,5352],0); -ELEMENTS[11427] = Fluid3D([4791,4845,5352,4937],0); -ELEMENTS[11428] = Fluid3D([4993,4791,5352,5187],0); -ELEMENTS[11429] = Fluid3D([4845,4993,5352,5316],0); -ELEMENTS[11430] = Fluid3D([4845,4434,4714,4472],0); -ELEMENTS[11431] = Fluid3D([4714,4845,4472,5008],0); -ELEMENTS[11432] = Fluid3D([4714,4591,5120,4618],0); -ELEMENTS[11433] = Fluid3D([4714,4591,4618,4317],0); -ELEMENTS[11434] = Fluid3D([4618,4714,4317,4815],0); -ELEMENTS[11435] = Fluid3D([4714,4317,4815,4472],0); -ELEMENTS[11436] = Fluid3D([4714,4317,4472,4434],0); -ELEMENTS[11437] = Fluid3D([4815,4714,4472,5008],0); -ELEMENTS[11438] = Fluid3D([5120,4714,4618,4815],0); -ELEMENTS[11439] = Fluid3D([4591,5120,4618,4907],0); -ELEMENTS[11440] = Fluid3D([4743,5187,5267,5269],0); -ELEMENTS[11441] = Fluid3D([5187,5267,5269,5769],0); -ELEMENTS[11442] = Fluid3D([4743,5187,5269,4791],0); -ELEMENTS[11443] = Fluid3D([5267,5269,5769,5689],0); -ELEMENTS[11444] = Fluid3D([5769,5267,5689,5887],0); -ELEMENTS[11445] = Fluid3D([5769,5267,5887,5468],0); -ELEMENTS[11446] = Fluid3D([5267,5269,5689,5060],0); -ELEMENTS[11447] = Fluid3D([5267,5269,5060,4743],0); -ELEMENTS[11448] = Fluid3D([5269,5769,5689,5893],0); -ELEMENTS[11449] = Fluid3D([5769,5689,5893,6306],0); -ELEMENTS[11450] = Fluid3D([5769,5689,6306,5887],0); -ELEMENTS[11451] = Fluid3D([5269,5689,5060,5493],0); -ELEMENTS[11452] = Fluid3D([5269,5689,5493,5893],0); -ELEMENTS[11453] = Fluid3D([5689,5060,5493,5488],0); -ELEMENTS[11454] = Fluid3D([5060,5493,5488,5059],0); -ELEMENTS[11455] = Fluid3D([5493,5488,5059,5675],0); -ELEMENTS[11456] = Fluid3D([5059,5493,5675,5273],0); -ELEMENTS[11457] = Fluid3D([5675,5059,5273,5211],0); -ELEMENTS[11458] = Fluid3D([5488,5059,5675,5211],0); -ELEMENTS[11459] = Fluid3D([5273,5675,5211,5490],0); -ELEMENTS[11460] = Fluid3D([5211,5273,5490,4715],0); -ELEMENTS[11461] = Fluid3D([5273,5675,5490,5719],0); -ELEMENTS[11462] = Fluid3D([5493,5488,5675,6021],0); -ELEMENTS[11463] = Fluid3D([5675,5493,6021,5978],0); -ELEMENTS[11464] = Fluid3D([5488,5675,6021,6048],0); -ELEMENTS[11465] = Fluid3D([5488,5675,6048,5485],0); -ELEMENTS[11466] = Fluid3D([5488,5675,5485,5211],0); -ELEMENTS[11467] = Fluid3D([5675,5485,5211,5833],0); -ELEMENTS[11468] = Fluid3D([5485,5211,5833,5304],0); -ELEMENTS[11469] = Fluid3D([5485,5211,5304,4839],0); -ELEMENTS[11470] = Fluid3D([5211,5833,5304,5490],0); -ELEMENTS[11471] = Fluid3D([5211,5833,5490,5675],0); -ELEMENTS[11472] = Fluid3D([5485,5211,4839,5488],0); -ELEMENTS[11473] = Fluid3D([5833,5485,5304,5821],0); -ELEMENTS[11474] = Fluid3D([5833,5485,5821,6048],0); -ELEMENTS[11475] = Fluid3D([5304,5833,5821,6018],0); -ELEMENTS[11476] = Fluid3D([5833,5821,6018,6364],0); -ELEMENTS[11477] = Fluid3D([6018,5833,6364,6341],0); -ELEMENTS[11478] = Fluid3D([5304,5833,6018,5639],0); -ELEMENTS[11479] = Fluid3D([5821,6018,6364,7031],0); -ELEMENTS[11480] = Fluid3D([5833,6018,5639,6341],0); -ELEMENTS[11481] = Fluid3D([5833,5821,6364,6048],0); -ELEMENTS[11482] = Fluid3D([6364,5833,6048,6218],0); -ELEMENTS[11483] = Fluid3D([6048,6364,6218,6773],0); -ELEMENTS[11484] = Fluid3D([6048,6364,6773,6130],0); -ELEMENTS[11485] = Fluid3D([6048,6364,6130,5821],0); -ELEMENTS[11486] = Fluid3D([6364,5833,6218,6341],0); -ELEMENTS[11487] = Fluid3D([6773,6048,6130,6600],0); -ELEMENTS[11488] = Fluid3D([6364,6773,6130,6515],0); -ELEMENTS[11489] = Fluid3D([5675,5485,5833,6048],0); -ELEMENTS[11490] = Fluid3D([6364,6773,6515,7031],0); -ELEMENTS[11491] = Fluid3D([6364,6773,7031,6951],0); -ELEMENTS[11492] = Fluid3D([6364,6773,6951,6218],0); -ELEMENTS[11493] = Fluid3D([6951,6364,6218,6341],0); -ELEMENTS[11494] = Fluid3D([7031,6364,6951,6904],0); -ELEMENTS[11495] = Fluid3D([6048,5488,5485,6130],0); -ELEMENTS[11496] = Fluid3D([5675,6021,6048,6218],0); -ELEMENTS[11497] = Fluid3D([6048,5675,6218,5833],0); -ELEMENTS[11498] = Fluid3D([5675,6218,5833,5490],0); -ELEMENTS[11499] = Fluid3D([6021,5488,6048,6031],0); -ELEMENTS[11500] = Fluid3D([5493,5488,6021,5689],0); -ELEMENTS[11501] = Fluid3D([6021,5493,5689,5893],0); -ELEMENTS[11502] = Fluid3D([5488,6021,5689,6031],0); -ELEMENTS[11503] = Fluid3D([6021,5689,6031,6306],0); -ELEMENTS[11504] = Fluid3D([6048,6021,6031,6636],0); -ELEMENTS[11505] = Fluid3D([5269,5769,5893,5602],0); -ELEMENTS[11506] = Fluid3D([5769,5893,5602,6251],0); -ELEMENTS[11507] = Fluid3D([5769,5893,6251,6306],0); -ELEMENTS[11508] = Fluid3D([5269,5769,5602,5187],0); -ELEMENTS[11509] = Fluid3D([6048,6021,6636,6218],0); -ELEMENTS[11510] = Fluid3D([5689,5060,5488,5411],0); -ELEMENTS[11511] = Fluid3D([5689,5060,5411,5267],0); -ELEMENTS[11512] = Fluid3D([5060,5488,5411,4976],0); -ELEMENTS[11513] = Fluid3D([5060,5488,4976,5059],0); -ELEMENTS[11514] = Fluid3D([5488,5689,5411,6031],0); -ELEMENTS[11515] = Fluid3D([5488,5411,4976,5532],0); -ELEMENTS[11516] = Fluid3D([5411,4976,5532,4827],0); -ELEMENTS[11517] = Fluid3D([5488,5411,5532,6031],0); -ELEMENTS[11518] = Fluid3D([4976,5488,5532,5485],0); -ELEMENTS[11519] = Fluid3D([6021,6031,6636,6306],0); -ELEMENTS[11520] = Fluid3D([5187,5267,5769,5468],0); -ELEMENTS[11521] = Fluid3D([5267,5689,5887,5411],0); -ELEMENTS[11522] = Fluid3D([5411,5060,4976,4810],0); -ELEMENTS[11523] = Fluid3D([5411,5060,4810,5267],0); -ELEMENTS[11524] = Fluid3D([5060,4976,4810,4506],0); -ELEMENTS[11525] = Fluid3D([5060,4976,4506,5059],0); -ELEMENTS[11526] = Fluid3D([4810,5060,4506,4743],0); -ELEMENTS[11527] = Fluid3D([4976,5411,4810,4827],0); -ELEMENTS[11528] = Fluid3D([4976,4810,4506,4286],0); -ELEMENTS[11529] = Fluid3D([4399,4477,4059,4155],0); -ELEMENTS[11530] = Fluid3D([4399,4477,4155,4657],0); -ELEMENTS[11531] = Fluid3D([4059,4399,4155,3713],0); -ELEMENTS[11532] = Fluid3D([4937,4477,4399,4657],0); -ELEMENTS[11533] = Fluid3D([4512,4120,4264,4130],0); -ELEMENTS[11534] = Fluid3D([4264,4512,4130,4881],0); -ELEMENTS[11535] = Fluid3D([5187,5048,5468,5615],0); -ELEMENTS[11536] = Fluid3D([5187,5048,5615,4993],0); -ELEMENTS[11537] = Fluid3D([5048,5468,5615,5571],0); -ELEMENTS[11538] = Fluid3D([5048,5468,5571,4999],0); -ELEMENTS[11539] = Fluid3D([5468,5615,5571,6082],0); -ELEMENTS[11540] = Fluid3D([5571,5468,6082,5800],0); -ELEMENTS[11541] = Fluid3D([5468,5187,5615,5769],0); -ELEMENTS[11542] = Fluid3D([5468,5615,6082,5769],0); -ELEMENTS[11543] = Fluid3D([5571,5468,5800,4999],0); -ELEMENTS[11544] = Fluid3D([6082,5571,5800,6177],0); -ELEMENTS[11545] = Fluid3D([5571,5800,6177,5611],0); -ELEMENTS[11546] = Fluid3D([6082,5571,6177,6081],0); -ELEMENTS[11547] = Fluid3D([6082,5571,6081,5615],0); -ELEMENTS[11548] = Fluid3D([5571,6177,6081,5635],0); -ELEMENTS[11549] = Fluid3D([5571,6177,5635,5611],0); -ELEMENTS[11550] = Fluid3D([6081,5571,5635,5465],0); -ELEMENTS[11551] = Fluid3D([6081,5571,5465,5615],0); -ELEMENTS[11552] = Fluid3D([5571,5635,5465,4907],0); -ELEMENTS[11553] = Fluid3D([5800,6082,6177,6510],0); -ELEMENTS[11554] = Fluid3D([6177,5800,6510,6224],0); -ELEMENTS[11555] = Fluid3D([6177,5800,6224,5611],0); -ELEMENTS[11556] = Fluid3D([6082,6177,6510,6918],0); -ELEMENTS[11557] = Fluid3D([6082,6177,6918,6081],0); -ELEMENTS[11558] = Fluid3D([6177,6510,6918,6874],0); -ELEMENTS[11559] = Fluid3D([6177,6510,6874,6224],0); -ELEMENTS[11560] = Fluid3D([5800,6082,6510,6076],0); -ELEMENTS[11561] = Fluid3D([5800,6082,6076,5468],0); -ELEMENTS[11562] = Fluid3D([6510,6918,6874,7359],0); -ELEMENTS[11563] = Fluid3D([6082,6510,6076,6711],0); -ELEMENTS[11564] = Fluid3D([6918,6874,7359,7560],0); -ELEMENTS[11565] = Fluid3D([6918,6874,7560,6892],0); -ELEMENTS[11566] = Fluid3D([6918,6874,6892,6177],0); -ELEMENTS[11567] = Fluid3D([6076,6082,6711,5769],0); -ELEMENTS[11568] = Fluid3D([6510,6918,7359,6711],0); -ELEMENTS[11569] = Fluid3D([6082,6510,6711,6918],0); -ELEMENTS[11570] = Fluid3D([5571,5800,5611,4999],0); -ELEMENTS[11571] = Fluid3D([6177,6081,5635,6892],0); -ELEMENTS[11572] = Fluid3D([5800,6510,6224,6171],0); -ELEMENTS[11573] = Fluid3D([5800,6510,6171,6076],0); -ELEMENTS[11574] = Fluid3D([6510,6224,6171,6902],0); -ELEMENTS[11575] = Fluid3D([6171,6510,6902,6842],0); -ELEMENTS[11576] = Fluid3D([6171,6510,6842,6076],0); -ELEMENTS[11577] = Fluid3D([6902,6171,6842,6739],0); -ELEMENTS[11578] = Fluid3D([6902,6171,6739,6346],0); -ELEMENTS[11579] = Fluid3D([6902,6171,6346,6224],0); -ELEMENTS[11580] = Fluid3D([6171,6842,6739,6259],0); -ELEMENTS[11581] = Fluid3D([6510,6224,6902,6874],0); -ELEMENTS[11582] = Fluid3D([6171,6842,6259,6076],0); -ELEMENTS[11583] = Fluid3D([6842,6739,6259,7073],0); -ELEMENTS[11584] = Fluid3D([6842,6739,7073,7540],0); -ELEMENTS[11585] = Fluid3D([6259,6842,7073,6736],0); -ELEMENTS[11586] = Fluid3D([6259,6842,6736,6076],0); -ELEMENTS[11587] = Fluid3D([6739,7073,7540,7407],0); -ELEMENTS[11588] = Fluid3D([6739,7073,7407,6615],0); -ELEMENTS[11589] = Fluid3D([7073,7540,7407,7968],0); -ELEMENTS[11590] = Fluid3D([6739,7073,6615,6259],0); -ELEMENTS[11591] = Fluid3D([7073,7540,7968,7666],0); -ELEMENTS[11592] = Fluid3D([7073,7540,7666,6842],0); -ELEMENTS[11593] = Fluid3D([7968,7073,7666,7615],0); -ELEMENTS[11594] = Fluid3D([7666,7968,7615,8417],0); -ELEMENTS[11595] = Fluid3D([7968,7073,7615,7465],0); -ELEMENTS[11596] = Fluid3D([7968,7073,7465,7407],0); -ELEMENTS[11597] = Fluid3D([7073,7615,7465,6868],0); -ELEMENTS[11598] = Fluid3D([7465,7073,6868,6615],0); -ELEMENTS[11599] = Fluid3D([7073,7615,6868,6736],0); -ELEMENTS[11600] = Fluid3D([6842,6739,7540,6902],0); -ELEMENTS[11601] = Fluid3D([7540,7968,7666,8369],0); -ELEMENTS[11602] = Fluid3D([7540,7968,8369,8606],0); -ELEMENTS[11603] = Fluid3D([7968,7666,8369,8417],0); -ELEMENTS[11604] = Fluid3D([7666,7540,8369,7732],0); -ELEMENTS[11605] = Fluid3D([7540,8369,7732,8331],0); -ELEMENTS[11606] = Fluid3D([7732,7540,8331,6902],0); -ELEMENTS[11607] = Fluid3D([7666,7540,7732,6842],0); -ELEMENTS[11608] = Fluid3D([7540,8369,8331,8606],0); -ELEMENTS[11609] = Fluid3D([8369,7666,7732,8314],0); -ELEMENTS[11610] = Fluid3D([8369,7666,8314,8417],0); -ELEMENTS[11611] = Fluid3D([7666,7732,8314,7466],0); -ELEMENTS[11612] = Fluid3D([8314,7666,7466,7866],0); -ELEMENTS[11613] = Fluid3D([8314,7666,7866,8417],0); -ELEMENTS[11614] = Fluid3D([7666,7732,7466,6842],0); -ELEMENTS[11615] = Fluid3D([7732,8369,8314,8633],0); -ELEMENTS[11616] = Fluid3D([8314,7732,8633,8070],0); -ELEMENTS[11617] = Fluid3D([7732,8369,8633,8331],0); -ELEMENTS[11618] = Fluid3D([8369,8314,8633,8917],0); -ELEMENTS[11619] = Fluid3D([8369,8314,8917,8417],0); -ELEMENTS[11620] = Fluid3D([8314,7732,8070,7466],0); -ELEMENTS[11621] = Fluid3D([6224,5800,6171,5663],0); -ELEMENTS[11622] = Fluid3D([6224,5800,5663,5611],0); -ELEMENTS[11623] = Fluid3D([5800,6171,5663,5614],0); -ELEMENTS[11624] = Fluid3D([5800,6171,5614,6076],0); -ELEMENTS[11625] = Fluid3D([6171,6224,5663,6346],0); -ELEMENTS[11626] = Fluid3D([6171,5663,5614,5777],0); -ELEMENTS[11627] = Fluid3D([5614,6171,5777,6259],0); -ELEMENTS[11628] = Fluid3D([5663,5614,5777,5151],0); -ELEMENTS[11629] = Fluid3D([5614,5777,5151,5370],0); -ELEMENTS[11630] = Fluid3D([5777,5151,5370,5311],0); -ELEMENTS[11631] = Fluid3D([6171,5663,5777,6346],0); -ELEMENTS[11632] = Fluid3D([5777,5151,5311,5421],0); -ELEMENTS[11633] = Fluid3D([5777,5151,5421,5663],0); -ELEMENTS[11634] = Fluid3D([5151,5311,5421,4900],0); -ELEMENTS[11635] = Fluid3D([5151,5311,4900,4752],0); -ELEMENTS[11636] = Fluid3D([5151,5311,4752,5370],0); -ELEMENTS[11637] = Fluid3D([5421,5151,4900,5069],0); -ELEMENTS[11638] = Fluid3D([5421,5151,5069,5663],0); -ELEMENTS[11639] = Fluid3D([5151,4900,5069,4608],0); -ELEMENTS[11640] = Fluid3D([4900,5069,4608,4561],0); -ELEMENTS[11641] = Fluid3D([4900,5069,4561,5219],0); -ELEMENTS[11642] = Fluid3D([4900,5069,5219,5421],0); -ELEMENTS[11643] = Fluid3D([5151,4900,4608,4752],0); -ELEMENTS[11644] = Fluid3D([5614,5777,5370,6259],0); -ELEMENTS[11645] = Fluid3D([5663,5614,5151,4999],0); -ELEMENTS[11646] = Fluid3D([5663,5800,5614,4999],0); -ELEMENTS[11647] = Fluid3D([6171,6739,6346,5777],0); -ELEMENTS[11648] = Fluid3D([6739,6171,6259,5777],0); -ELEMENTS[11649] = Fluid3D([6510,6902,6842,7359],0); -ELEMENTS[11650] = Fluid3D([5615,5048,5571,5465],0); -ELEMENTS[11651] = Fluid3D([5635,6081,5465,6009],0); -ELEMENTS[11652] = Fluid3D([6081,5465,6009,5915],0); -ELEMENTS[11653] = Fluid3D([5635,6081,6009,6892],0); -ELEMENTS[11654] = Fluid3D([5465,6009,5915,5516],0); -ELEMENTS[11655] = Fluid3D([5465,5635,6009,5429],0); -ELEMENTS[11656] = Fluid3D([5915,5465,5516,5316],0); -ELEMENTS[11657] = Fluid3D([5465,6009,5516,5429],0); -ELEMENTS[11658] = Fluid3D([5465,5635,5429,4907],0); -ELEMENTS[11659] = Fluid3D([6081,5465,5915,5615],0); -ELEMENTS[11660] = Fluid3D([6009,6081,5915,6589],0); -ELEMENTS[11661] = Fluid3D([6009,6081,6589,6892],0); -ELEMENTS[11662] = Fluid3D([6081,5915,6589,6368],0); -ELEMENTS[11663] = Fluid3D([5915,6589,6368,6488],0); -ELEMENTS[11664] = Fluid3D([5915,6009,6589,6321],0); -ELEMENTS[11665] = Fluid3D([5915,6589,6488,6321],0); -ELEMENTS[11666] = Fluid3D([5915,6009,6321,5516],0); -ELEMENTS[11667] = Fluid3D([6589,6368,6488,7148],0); -ELEMENTS[11668] = Fluid3D([6368,6488,7148,6761],0); -ELEMENTS[11669] = Fluid3D([6589,6368,7148,6918],0); -ELEMENTS[11670] = Fluid3D([6488,6589,7148,7124],0); -ELEMENTS[11671] = Fluid3D([6368,6488,6761,5996],0); -ELEMENTS[11672] = Fluid3D([6589,7148,7124,7451],0); -ELEMENTS[11673] = Fluid3D([6589,7148,7451,6918],0); -ELEMENTS[11674] = Fluid3D([6488,6761,5996,6427],0); -ELEMENTS[11675] = Fluid3D([6488,6761,6427,7189],0); -ELEMENTS[11676] = Fluid3D([6488,6761,7189,7148],0); -ELEMENTS[11677] = Fluid3D([6761,5996,6427,6248],0); -ELEMENTS[11678] = Fluid3D([6761,5996,6248,6251],0); -ELEMENTS[11679] = Fluid3D([6427,6761,6248,7034],0); -ELEMENTS[11680] = Fluid3D([6427,6761,7034,7189],0); -ELEMENTS[11681] = Fluid3D([6761,6248,7034,6947],0); -ELEMENTS[11682] = Fluid3D([6761,6248,6947,6251],0); -ELEMENTS[11683] = Fluid3D([7034,6761,6947,7589],0); -ELEMENTS[11684] = Fluid3D([7034,6761,7589,7189],0); -ELEMENTS[11685] = Fluid3D([6761,6947,7589,7147],0); -ELEMENTS[11686] = Fluid3D([6947,7589,7147,7707],0); -ELEMENTS[11687] = Fluid3D([6947,7589,7707,7681],0); -ELEMENTS[11688] = Fluid3D([6947,7589,7681,7034],0); -ELEMENTS[11689] = Fluid3D([6761,6947,7147,6251],0); -ELEMENTS[11690] = Fluid3D([6368,6488,5996,5915],0); -ELEMENTS[11691] = Fluid3D([6488,6589,7124,6321],0); -ELEMENTS[11692] = Fluid3D([6081,5915,6368,5615],0); -ELEMENTS[11693] = Fluid3D([6589,6081,6368,6918],0); -ELEMENTS[11694] = Fluid3D([5996,6427,6248,5779],0); -ELEMENTS[11695] = Fluid3D([5996,6427,5779,5857],0); -ELEMENTS[11696] = Fluid3D([6427,5779,5857,6040],0); -ELEMENTS[11697] = Fluid3D([5779,5857,6040,5390],0); -ELEMENTS[11698] = Fluid3D([6040,5779,5390,5607],0); -ELEMENTS[11699] = Fluid3D([6040,5779,5607,6126],0); -ELEMENTS[11700] = Fluid3D([6040,5779,6126,6427],0); -ELEMENTS[11701] = Fluid3D([6427,6248,5779,6126],0); -ELEMENTS[11702] = Fluid3D([5779,5857,5390,5316],0); -ELEMENTS[11703] = Fluid3D([5779,5996,5857,5316],0); -ELEMENTS[11704] = Fluid3D([5857,6427,6040,6449],0); -ELEMENTS[11705] = Fluid3D([5857,6427,6449,6488],0); -ELEMENTS[11706] = Fluid3D([6427,6040,6449,6821],0); -ELEMENTS[11707] = Fluid3D([6427,6040,6821,6126],0); -ELEMENTS[11708] = Fluid3D([6449,6427,6821,7189],0); -ELEMENTS[11709] = Fluid3D([6040,5857,6449,5594],0); -ELEMENTS[11710] = Fluid3D([6040,6449,6821,6223],0); -ELEMENTS[11711] = Fluid3D([5996,6427,5857,6488],0); -ELEMENTS[11712] = Fluid3D([6248,5996,5779,5352],0); -ELEMENTS[11713] = Fluid3D([6874,6510,7359,6902],0); -ELEMENTS[11714] = Fluid3D([5635,6009,5429,6037],0); -ELEMENTS[11715] = Fluid3D([6009,5429,6037,5916],0); -ELEMENTS[11716] = Fluid3D([5429,6037,5916,5560],0); -ELEMENTS[11717] = Fluid3D([5429,5635,6037,5518],0); -ELEMENTS[11718] = Fluid3D([5429,5635,5518,5201],0); -ELEMENTS[11719] = Fluid3D([5518,5429,5201,4887],0); -ELEMENTS[11720] = Fluid3D([5518,5429,4887,5560],0); -ELEMENTS[11721] = Fluid3D([5635,6009,6037,6892],0); -ELEMENTS[11722] = Fluid3D([5429,5635,5201,4907],0); -ELEMENTS[11723] = Fluid3D([6037,5916,5560,6194],0); -ELEMENTS[11724] = Fluid3D([6037,5916,6194,6543],0); -ELEMENTS[11725] = Fluid3D([5916,6194,6543,6442],0); -ELEMENTS[11726] = Fluid3D([5916,6194,6442,5604],0); -ELEMENTS[11727] = Fluid3D([5916,5560,6194,5430],0); -ELEMENTS[11728] = Fluid3D([5560,6037,6194,6004],0); -ELEMENTS[11729] = Fluid3D([5560,6037,6004,5518],0); -ELEMENTS[11730] = Fluid3D([6037,6194,6004,6949],0); -ELEMENTS[11731] = Fluid3D([6194,6004,6949,6540],0); -ELEMENTS[11732] = Fluid3D([6194,5560,6004,5802],0); -ELEMENTS[11733] = Fluid3D([6194,5560,5802,5430],0); -ELEMENTS[11734] = Fluid3D([5560,5802,5430,4891],0); -ELEMENTS[11735] = Fluid3D([6194,6004,6540,5802],0); -ELEMENTS[11736] = Fluid3D([6037,6194,6949,6543],0); -ELEMENTS[11737] = Fluid3D([6037,5916,6543,6009],0); -ELEMENTS[11738] = Fluid3D([6009,5429,5916,5516],0); -ELEMENTS[11739] = Fluid3D([5429,6037,5560,5518],0); -ELEMENTS[11740] = Fluid3D([5635,6037,5518,6137],0); -ELEMENTS[11741] = Fluid3D([5635,6037,6137,6892],0); -ELEMENTS[11742] = Fluid3D([6037,5518,6137,6004],0); -ELEMENTS[11743] = Fluid3D([5518,5635,6137,5611],0); -ELEMENTS[11744] = Fluid3D([6009,6589,6321,6543],0); -ELEMENTS[11745] = Fluid3D([5916,5429,5560,5032],0); -ELEMENTS[11746] = Fluid3D([5311,5421,4900,5305],0); -ELEMENTS[11747] = Fluid3D([5311,5421,5305,5879],0); -ELEMENTS[11748] = Fluid3D([4900,5311,5305,4850],0); -ELEMENTS[11749] = Fluid3D([5421,5305,5879,5816],0); -ELEMENTS[11750] = Fluid3D([5305,5879,5816,5831],0); -ELEMENTS[11751] = Fluid3D([5421,5305,5816,5219],0); -ELEMENTS[11752] = Fluid3D([4900,5311,4850,4752],0); -ELEMENTS[11753] = Fluid3D([5305,5879,5831,5530],0); -ELEMENTS[11754] = Fluid3D([5305,5879,5530,5311],0); -ELEMENTS[11755] = Fluid3D([5879,5831,5530,6197],0); -ELEMENTS[11756] = Fluid3D([5879,5831,6197,6438],0); -ELEMENTS[11757] = Fluid3D([6197,5879,6438,6528],0); -ELEMENTS[11758] = Fluid3D([5831,5530,6197,5830],0); -ELEMENTS[11759] = Fluid3D([5831,5530,5830,5278],0); -ELEMENTS[11760] = Fluid3D([5831,5530,5278,5305],0); -ELEMENTS[11761] = Fluid3D([5879,5831,6438,5816],0); -ELEMENTS[11762] = Fluid3D([6197,5879,6528,5965],0); -ELEMENTS[11763] = Fluid3D([6197,5879,5965,5530],0); -ELEMENTS[11764] = Fluid3D([5879,6528,5965,5777],0); -ELEMENTS[11765] = Fluid3D([6528,6197,5965,6628],0); -ELEMENTS[11766] = Fluid3D([6197,5965,6628,5993],0); -ELEMENTS[11767] = Fluid3D([6528,6197,6628,7024],0); -ELEMENTS[11768] = Fluid3D([6197,6628,7024,6677],0); -ELEMENTS[11769] = Fluid3D([6197,6628,6677,5993],0); -ELEMENTS[11770] = Fluid3D([6528,6197,7024,6438],0); -ELEMENTS[11771] = Fluid3D([5965,6528,6628,6615],0); -ELEMENTS[11772] = Fluid3D([6528,6628,6615,7407],0); -ELEMENTS[11773] = Fluid3D([5965,6528,6615,5777],0); -ELEMENTS[11774] = Fluid3D([6197,5965,5993,5530],0); -ELEMENTS[11775] = Fluid3D([5965,6628,5993,6169],0); -ELEMENTS[11776] = Fluid3D([5965,6628,6169,6615],0); -ELEMENTS[11777] = Fluid3D([5993,5965,6169,5524],0); -ELEMENTS[11778] = Fluid3D([6628,5993,6169,6575],0); -ELEMENTS[11779] = Fluid3D([6628,5993,6575,6677],0); -ELEMENTS[11780] = Fluid3D([5965,6169,5524,5771],0); -ELEMENTS[11781] = Fluid3D([5965,6169,5771,6615],0); -ELEMENTS[11782] = Fluid3D([5524,5965,5771,5311],0); -ELEMENTS[11783] = Fluid3D([5993,5965,5524,5530],0); -ELEMENTS[11784] = Fluid3D([6169,5524,5771,5696],0); -ELEMENTS[11785] = Fluid3D([5524,5771,5696,5223],0); -ELEMENTS[11786] = Fluid3D([6169,5524,5696,5805],0); -ELEMENTS[11787] = Fluid3D([5696,6169,5805,6253],0); -ELEMENTS[11788] = Fluid3D([5696,6169,6253,6264],0); -ELEMENTS[11789] = Fluid3D([5696,6169,6264,5771],0); -ELEMENTS[11790] = Fluid3D([6169,5524,5805,5993],0); -ELEMENTS[11791] = Fluid3D([5524,5696,5805,5295],0); -ELEMENTS[11792] = Fluid3D([5311,5421,5879,5777],0); -ELEMENTS[11793] = Fluid3D([5421,4900,5305,5219],0); -ELEMENTS[11794] = Fluid3D([5311,5305,4850,5530],0); -ELEMENTS[11795] = Fluid3D([5879,5421,5816,6346],0); -ELEMENTS[11796] = Fluid3D([5816,5305,5831,5423],0); -ELEMENTS[11797] = Fluid3D([5816,5305,5423,5219],0); -ELEMENTS[11798] = Fluid3D([5831,5816,5423,6098],0); -ELEMENTS[11799] = Fluid3D([5831,5816,6098,6438],0); -ELEMENTS[11800] = Fluid3D([5423,5831,6098,5759],0); -ELEMENTS[11801] = Fluid3D([5831,6098,5759,6388],0); -ELEMENTS[11802] = Fluid3D([5831,6098,6388,6438],0); -ELEMENTS[11803] = Fluid3D([5305,5831,5423,5278],0); -ELEMENTS[11804] = Fluid3D([6098,5759,6388,6332],0); -ELEMENTS[11805] = Fluid3D([6388,6098,6332,7193],0); -ELEMENTS[11806] = Fluid3D([6098,5759,6332,5754],0); -ELEMENTS[11807] = Fluid3D([6098,5759,5754,5423],0); -ELEMENTS[11808] = Fluid3D([5759,6388,6332,6210],0); -ELEMENTS[11809] = Fluid3D([6388,6332,6210,6856],0); -ELEMENTS[11810] = Fluid3D([6210,6388,6856,6261],0); -ELEMENTS[11811] = Fluid3D([6856,6210,6261,6497],0); -ELEMENTS[11812] = Fluid3D([6856,6210,6497,6806],0); -ELEMENTS[11813] = Fluid3D([6856,6210,6806,6332],0); -ELEMENTS[11814] = Fluid3D([6261,6856,6497,7432],0); -ELEMENTS[11815] = Fluid3D([6497,6856,6806,7432],0); -ELEMENTS[11816] = Fluid3D([6388,6856,6261,7272],0); -ELEMENTS[11817] = Fluid3D([6210,6497,6806,6079],0); -ELEMENTS[11818] = Fluid3D([6210,6261,6497,5804],0); -ELEMENTS[11819] = Fluid3D([6806,6210,6079,6181],0); -ELEMENTS[11820] = Fluid3D([6806,6210,6181,6332],0); -ELEMENTS[11821] = Fluid3D([6210,6497,6079,5804],0); -ELEMENTS[11822] = Fluid3D([6210,6261,5804,5759],0); -ELEMENTS[11823] = Fluid3D([6210,6079,6181,5613],0); -ELEMENTS[11824] = Fluid3D([6210,6079,5613,5804],0); -ELEMENTS[11825] = Fluid3D([6210,6388,6261,5759],0); -ELEMENTS[11826] = Fluid3D([6181,6210,5613,6332],0); -ELEMENTS[11827] = Fluid3D([6079,6806,6181,6483],0); -ELEMENTS[11828] = Fluid3D([6497,6806,6079,6624],0); -ELEMENTS[11829] = Fluid3D([6079,6806,6483,6624],0); -ELEMENTS[11830] = Fluid3D([6079,6497,6624,6111],0); -ELEMENTS[11831] = Fluid3D([6079,6497,6111,5804],0); -ELEMENTS[11832] = Fluid3D([6624,6079,6111,6097],0); -ELEMENTS[11833] = Fluid3D([6624,6079,6097,6483],0); -ELEMENTS[11834] = Fluid3D([6806,6181,6483,7119],0); -ELEMENTS[11835] = Fluid3D([6261,6497,5804,6131],0); -ELEMENTS[11836] = Fluid3D([6497,5804,6131,6111],0); -ELEMENTS[11837] = Fluid3D([5804,6261,6131,5830],0); -ELEMENTS[11838] = Fluid3D([6079,6181,5613,5717],0); -ELEMENTS[11839] = Fluid3D([5613,6079,5717,5466],0); -ELEMENTS[11840] = Fluid3D([5613,6079,5466,5804],0); -ELEMENTS[11841] = Fluid3D([6497,6806,6624,7337],0); -ELEMENTS[11842] = Fluid3D([6111,6624,6097,7076],0); -ELEMENTS[11843] = Fluid3D([6111,6624,7076,6993],0); -ELEMENTS[11844] = Fluid3D([6111,6624,6993,6497],0); -ELEMENTS[11845] = Fluid3D([5759,6332,5754,5613],0); -ELEMENTS[11846] = Fluid3D([6181,6079,6483,5717],0); -ELEMENTS[11847] = Fluid3D([5816,5423,6098,5737],0); -ELEMENTS[11848] = Fluid3D([5816,5423,5737,5219],0); -ELEMENTS[11849] = Fluid3D([5423,6098,5737,5754],0); -ELEMENTS[11850] = Fluid3D([6098,5816,5737,6353],0); -ELEMENTS[11851] = Fluid3D([5816,5737,6353,5744],0); -ELEMENTS[11852] = Fluid3D([6098,5816,6353,6438],0); -ELEMENTS[11853] = Fluid3D([5816,5737,5744,5219],0); -ELEMENTS[11854] = Fluid3D([5737,6098,6353,6302],0); -ELEMENTS[11855] = Fluid3D([6353,5737,6302,6160],0); -ELEMENTS[11856] = Fluid3D([5737,6098,6302,5754],0); -ELEMENTS[11857] = Fluid3D([5737,6302,6160,5796],0); -ELEMENTS[11858] = Fluid3D([5737,6302,5796,5754],0); -ELEMENTS[11859] = Fluid3D([6302,6160,5796,6464],0); -ELEMENTS[11860] = Fluid3D([6302,6160,6464,6935],0); -ELEMENTS[11861] = Fluid3D([6302,6160,6935,6353],0); -ELEMENTS[11862] = Fluid3D([6160,5796,6464,5966],0); -ELEMENTS[11863] = Fluid3D([6160,5796,5966,5591],0); -ELEMENTS[11864] = Fluid3D([6160,5796,5591,5737],0); -ELEMENTS[11865] = Fluid3D([5796,6464,5966,5971],0); -ELEMENTS[11866] = Fluid3D([5966,5796,5971,5447],0); -ELEMENTS[11867] = Fluid3D([5966,5796,5447,5591],0); -ELEMENTS[11868] = Fluid3D([5796,6464,5971,6182],0); -ELEMENTS[11869] = Fluid3D([6464,5971,6182,6669],0); -ELEMENTS[11870] = Fluid3D([6464,5971,6669,6460],0); -ELEMENTS[11871] = Fluid3D([6464,5971,6460,5966],0); -ELEMENTS[11872] = Fluid3D([5796,6464,6182,6302],0); -ELEMENTS[11873] = Fluid3D([6098,6353,6302,6861],0); -ELEMENTS[11874] = Fluid3D([6302,6098,6861,6332],0); -ELEMENTS[11875] = Fluid3D([6353,6302,6861,6935],0); -ELEMENTS[11876] = Fluid3D([6098,6353,6861,6438],0); -ELEMENTS[11877] = Fluid3D([6353,5737,6160,5744],0); -ELEMENTS[11878] = Fluid3D([6332,6098,5754,6302],0); -ELEMENTS[11879] = Fluid3D([6332,5759,6210,5613],0); -ELEMENTS[11880] = Fluid3D([5423,5831,5759,5278],0); -ELEMENTS[11881] = Fluid3D([6079,6111,6097,5466],0); -ELEMENTS[11882] = Fluid3D([5305,4900,4850,4730],0); -ELEMENTS[11883] = Fluid3D([5305,4900,4730,5219],0); -ELEMENTS[11884] = Fluid3D([4850,5305,4730,5278],0); -ELEMENTS[11885] = Fluid3D([4900,4850,4730,4379],0); -ELEMENTS[11886] = Fluid3D([4850,4730,4379,4418],0); -ELEMENTS[11887] = Fluid3D([4730,4379,4418,4088],0); -ELEMENTS[11888] = Fluid3D([4379,4418,4088,3947],0); -ELEMENTS[11889] = Fluid3D([4900,4850,4379,4752],0); -ELEMENTS[11890] = Fluid3D([4730,4900,4379,4561],0); -ELEMENTS[11891] = Fluid3D([4379,4418,3947,4314],0); -ELEMENTS[11892] = Fluid3D([4379,4418,4314,4850],0); -ELEMENTS[11893] = Fluid3D([4418,3947,4314,4063],0); -ELEMENTS[11894] = Fluid3D([3947,4379,4314,4005],0); -ELEMENTS[11895] = Fluid3D([4379,4314,4005,4752],0); -ELEMENTS[11896] = Fluid3D([3947,4314,4063,3819],0); -ELEMENTS[11897] = Fluid3D([3947,4314,3819,4005],0); -ELEMENTS[11898] = Fluid3D([4314,4063,3819,4121],0); -ELEMENTS[11899] = Fluid3D([4063,3819,4121,3762],0); -ELEMENTS[11900] = Fluid3D([4063,3819,3762,3583],0); -ELEMENTS[11901] = Fluid3D([4063,3819,3583,3947],0); -ELEMENTS[11902] = Fluid3D([4314,4063,4121,4595],0); -ELEMENTS[11903] = Fluid3D([4063,4121,4595,4250],0); -ELEMENTS[11904] = Fluid3D([4314,4063,4595,4418],0); -ELEMENTS[11905] = Fluid3D([4063,4121,4250,3762],0); -ELEMENTS[11906] = Fluid3D([3947,4379,4005,4004],0); -ELEMENTS[11907] = Fluid3D([4379,4005,4004,4255],0); -ELEMENTS[11908] = Fluid3D([4005,4004,4255,3893],0); -ELEMENTS[11909] = Fluid3D([3947,4379,4004,4088],0); -ELEMENTS[11910] = Fluid3D([4255,4005,3893,4221],0); -ELEMENTS[11911] = Fluid3D([4379,4005,4255,4752],0); -ELEMENTS[11912] = Fluid3D([4418,3947,4063,3985],0); -ELEMENTS[11913] = Fluid3D([4418,3947,3985,4088],0); -ELEMENTS[11914] = Fluid3D([3947,4063,3985,3583],0); -ELEMENTS[11915] = Fluid3D([4063,4418,3985,4410],0); -ELEMENTS[11916] = Fluid3D([4418,3985,4410,4368],0); -ELEMENTS[11917] = Fluid3D([4410,4418,4368,4890],0); -ELEMENTS[11918] = Fluid3D([4410,4418,4890,4595],0); -ELEMENTS[11919] = Fluid3D([4063,4418,4410,4595],0); -ELEMENTS[11920] = Fluid3D([3985,4063,4410,3864],0); -ELEMENTS[11921] = Fluid3D([4410,3985,3864,4009],0); -ELEMENTS[11922] = Fluid3D([4063,4410,3864,4250],0); -ELEMENTS[11923] = Fluid3D([3985,4063,3864,3583],0); -ELEMENTS[11924] = Fluid3D([4410,3985,4009,4368],0); -ELEMENTS[11925] = Fluid3D([4418,3985,4368,4088],0); -ELEMENTS[11926] = Fluid3D([4850,4730,4418,4890],0); -ELEMENTS[11927] = Fluid3D([4005,3947,4004,3639],0); -ELEMENTS[11928] = Fluid3D([3947,4004,3639,3638],0); -ELEMENTS[11929] = Fluid3D([4004,4005,3639,3893],0); -ELEMENTS[11930] = Fluid3D([4005,3947,3639,3819],0); -ELEMENTS[11931] = Fluid3D([3639,3947,3638,3583],0); -ELEMENTS[11932] = Fluid3D([4004,3639,3638,3417],0); -ELEMENTS[11933] = Fluid3D([4004,3639,3417,3671],0); -ELEMENTS[11934] = Fluid3D([3638,4004,3417,3743],0); -ELEMENTS[11935] = Fluid3D([4004,3417,3743,3820],0); -ELEMENTS[11936] = Fluid3D([3639,3417,3671,3158],0); -ELEMENTS[11937] = Fluid3D([3639,3417,3158,3189],0); -ELEMENTS[11938] = Fluid3D([3639,3638,3417,3189],0); -ELEMENTS[11939] = Fluid3D([4004,3417,3820,3671],0); -ELEMENTS[11940] = Fluid3D([3638,4004,3743,4088],0); -ELEMENTS[11941] = Fluid3D([4004,3639,3671,3893],0); -ELEMENTS[11942] = Fluid3D([4730,4379,4088,4561],0); -ELEMENTS[11943] = Fluid3D([3947,4004,3638,4088],0); -ELEMENTS[11944] = Fluid3D([3819,4121,3762,3771],0); -ELEMENTS[11945] = Fluid3D([3819,4121,3771,3883],0); -ELEMENTS[11946] = Fluid3D([3771,3819,3883,3245],0); -ELEMENTS[11947] = Fluid3D([4121,3762,3771,3905],0); -ELEMENTS[11948] = Fluid3D([4121,3762,3905,4250],0); -ELEMENTS[11949] = Fluid3D([3771,4121,3905,4237],0); -ELEMENTS[11950] = Fluid3D([3762,3819,3771,3501],0); -ELEMENTS[11951] = Fluid3D([3762,3819,3501,3583],0); -ELEMENTS[11952] = Fluid3D([3819,3771,3501,3245],0); -ELEMENTS[11953] = Fluid3D([3819,3501,3583,3639],0); -ELEMENTS[11954] = Fluid3D([3771,3762,3501,3334],0); -ELEMENTS[11955] = Fluid3D([3501,3762,3583,3334],0); -ELEMENTS[11956] = Fluid3D([3762,3771,3905,3334],0); -ELEMENTS[11957] = Fluid3D([4418,4730,4088,4368],0); -ELEMENTS[11958] = Fluid3D([5993,6169,6575,5805],0); -ELEMENTS[11959] = Fluid3D([4418,4368,4890,4730],0); -ELEMENTS[11960] = Fluid3D([5759,5831,6388,5830],0); -ELEMENTS[11961] = Fluid3D([4477,4589,4059,4419],0); -ELEMENTS[11962] = Fluid3D([4714,5120,5316,4815],0); -ELEMENTS[11963] = Fluid3D([4999,5048,4907,5571],0); -ELEMENTS[11964] = Fluid3D([6739,6902,6346,7170],0); -ELEMENTS[11965] = Fluid3D([6902,6346,7170,6896],0); -ELEMENTS[11966] = Fluid3D([6739,6902,7170,7540],0); -ELEMENTS[11967] = Fluid3D([6346,7170,6896,6728],0); -ELEMENTS[11968] = Fluid3D([6346,7170,6728,6528],0); -ELEMENTS[11969] = Fluid3D([6896,6346,6728,6233],0); -ELEMENTS[11970] = Fluid3D([7170,6896,6728,7536],0); -ELEMENTS[11971] = Fluid3D([6346,6728,6233,5816],0); -ELEMENTS[11972] = Fluid3D([6896,6728,7536,6912],0); -ELEMENTS[11973] = Fluid3D([6896,6728,6912,6233],0); -ELEMENTS[11974] = Fluid3D([6728,7536,6912,7227],0); -ELEMENTS[11975] = Fluid3D([6912,6728,7227,6353],0); -ELEMENTS[11976] = Fluid3D([6728,7227,6353,6861],0); -ELEMENTS[11977] = Fluid3D([6728,7536,7227,7416],0); -ELEMENTS[11978] = Fluid3D([7536,7227,7416,8072],0); -ELEMENTS[11979] = Fluid3D([7536,7227,8072,7791],0); -ELEMENTS[11980] = Fluid3D([7536,7227,7791,6912],0); -ELEMENTS[11981] = Fluid3D([7227,7416,8072,7675],0); -ELEMENTS[11982] = Fluid3D([6728,7536,7416,7170],0); -ELEMENTS[11983] = Fluid3D([7227,7416,7675,6861],0); -ELEMENTS[11984] = Fluid3D([7675,7227,6861,7610],0); -ELEMENTS[11985] = Fluid3D([6861,7675,7610,7250],0); -ELEMENTS[11986] = Fluid3D([7675,7227,7610,8072],0); -ELEMENTS[11987] = Fluid3D([7416,8072,7675,8181],0); -ELEMENTS[11988] = Fluid3D([7416,8072,8181,8494],0); -ELEMENTS[11989] = Fluid3D([8072,7675,8181,8512],0); -ELEMENTS[11990] = Fluid3D([7675,8181,8512,8138],0); -ELEMENTS[11991] = Fluid3D([8181,8072,8512,8976],0); -ELEMENTS[11992] = Fluid3D([8072,7675,8512,7610],0); -ELEMENTS[11993] = Fluid3D([8512,7675,8138,8052],0); -ELEMENTS[11994] = Fluid3D([8138,8512,8052,9214],0); -ELEMENTS[11995] = Fluid3D([7675,8138,8052,7193],0); -ELEMENTS[11996] = Fluid3D([7675,8181,8138,7961],0); -ELEMENTS[11997] = Fluid3D([8181,8138,7961,9206],0); -ELEMENTS[11998] = Fluid3D([8181,8072,8976,8494],0); -ELEMENTS[11999] = Fluid3D([8072,8976,8494,8784],0); -ELEMENTS[12000] = Fluid3D([8976,8494,8784,9421],0); -ELEMENTS[12001] = Fluid3D([8072,8976,8784,8846],0); -ELEMENTS[12002] = Fluid3D([8976,8784,8846,9828],0); -ELEMENTS[12003] = Fluid3D([8072,8976,8846,8512],0); -ELEMENTS[12004] = Fluid3D([8976,8846,8512,9461],0); -ELEMENTS[12005] = Fluid3D([8846,8512,9461,9013],0); -ELEMENTS[12006] = Fluid3D([8846,8512,9013,8207],0); -ELEMENTS[12007] = Fluid3D([8846,8512,8207,8072],0); -ELEMENTS[12008] = Fluid3D([9013,8846,8207,8793],0); -ELEMENTS[12009] = Fluid3D([9461,8846,9013,9466],0); -ELEMENTS[12010] = Fluid3D([9461,8846,9466,9828],0); -ELEMENTS[12011] = Fluid3D([8846,8207,8793,7791],0); -ELEMENTS[12012] = Fluid3D([8976,8846,9461,9828],0); -ELEMENTS[12013] = Fluid3D([8512,9013,8207,8052],0); -ELEMENTS[12014] = Fluid3D([8512,9461,9013,9214],0); -ELEMENTS[12015] = Fluid3D([9013,8846,8793,9466],0); -ELEMENTS[12016] = Fluid3D([8512,8976,9461,9206],0); -ELEMENTS[12017] = Fluid3D([8207,9013,8793,8412],0); -ELEMENTS[12018] = Fluid3D([9013,9461,9466,9923],0); -ELEMENTS[12019] = Fluid3D([8793,8207,8412,7916],0); -ELEMENTS[12020] = Fluid3D([8793,8207,7916,7791],0); -ELEMENTS[12021] = Fluid3D([9466,9013,9923,9544],0); -ELEMENTS[12022] = Fluid3D([9466,9013,9544,8793],0); -ELEMENTS[12023] = Fluid3D([9013,8793,8412,9544],0); -ELEMENTS[12024] = Fluid3D([9461,9466,9923,10357],0); -ELEMENTS[12025] = Fluid3D([9461,9466,10357,9828],0); -ELEMENTS[12026] = Fluid3D([8207,8412,7916,7610],0); -ELEMENTS[12027] = Fluid3D([7916,8207,7610,7791],0); -ELEMENTS[12028] = Fluid3D([9013,9923,9544,9306],0); -ELEMENTS[12029] = Fluid3D([8207,9013,8412,8006],0); -ELEMENTS[12030] = Fluid3D([9013,9923,9306,8935],0); -ELEMENTS[12031] = Fluid3D([9306,9013,8935,8006],0); -ELEMENTS[12032] = Fluid3D([8935,9306,8006,8702],0); -ELEMENTS[12033] = Fluid3D([8207,9013,8006,8052],0); -ELEMENTS[12034] = Fluid3D([8412,8793,7916,8629],0); -ELEMENTS[12035] = Fluid3D([8412,8793,8629,9544],0); -ELEMENTS[12036] = Fluid3D([8793,7916,8629,8487],0); -ELEMENTS[12037] = Fluid3D([7916,8412,8629,7842],0); -ELEMENTS[12038] = Fluid3D([7916,8629,8487,7910],0); -ELEMENTS[12039] = Fluid3D([7916,8629,7910,7842],0); -ELEMENTS[12040] = Fluid3D([7916,8412,7842,7472],0); -ELEMENTS[12041] = Fluid3D([8412,7842,7472,7829],0); -ELEMENTS[12042] = Fluid3D([8412,7842,7829,8635],0); -ELEMENTS[12043] = Fluid3D([8412,7842,8635,8629],0); -ELEMENTS[12044] = Fluid3D([7916,8412,7472,7610],0); -ELEMENTS[12045] = Fluid3D([7472,7916,7610,6935],0); -ELEMENTS[12046] = Fluid3D([7610,7472,6935,6302],0); -ELEMENTS[12047] = Fluid3D([8793,7916,8487,7791],0); -ELEMENTS[12048] = Fluid3D([9013,9461,9923,9214],0); -ELEMENTS[12049] = Fluid3D([7227,8072,7791,7610],0); -ELEMENTS[12050] = Fluid3D([6896,6346,6233,6224],0); -ELEMENTS[12051] = Fluid3D([7536,6896,6912,7515],0); -ELEMENTS[12052] = Fluid3D([6896,6912,7515,6676],0); -ELEMENTS[12053] = Fluid3D([7515,6896,6676,7210],0); -ELEMENTS[12054] = Fluid3D([6912,7536,7515,7791],0); -ELEMENTS[12055] = Fluid3D([7515,6896,7210,7691],0); -ELEMENTS[12056] = Fluid3D([7515,6896,7691,7536],0); -ELEMENTS[12057] = Fluid3D([7210,7515,7691,8019],0); -ELEMENTS[12058] = Fluid3D([7691,7210,8019,7716],0); -ELEMENTS[12059] = Fluid3D([7691,7210,7716,6902],0); -ELEMENTS[12060] = Fluid3D([7210,7515,8019,7320],0); -ELEMENTS[12061] = Fluid3D([7210,7515,7320,6676],0); -ELEMENTS[12062] = Fluid3D([7515,8019,7320,8304],0); -ELEMENTS[12063] = Fluid3D([8019,7320,8304,8120],0); -ELEMENTS[12064] = Fluid3D([8019,7320,8120,7628],0); -ELEMENTS[12065] = Fluid3D([8019,7320,7628,7210],0); -ELEMENTS[12066] = Fluid3D([7515,8019,8304,8378],0); -ELEMENTS[12067] = Fluid3D([7515,8019,8378,7691],0); -ELEMENTS[12068] = Fluid3D([8019,8304,8378,8766],0); -ELEMENTS[12069] = Fluid3D([8378,8019,8766,8658],0); -ELEMENTS[12070] = Fluid3D([8378,8019,8658,7691],0); -ELEMENTS[12071] = Fluid3D([8019,8304,8766,8120],0); -ELEMENTS[12072] = Fluid3D([6896,7210,7691,6902],0); -ELEMENTS[12073] = Fluid3D([8304,8378,8766,8970],0); -ELEMENTS[12074] = Fluid3D([8378,8766,8970,9225],0); -ELEMENTS[12075] = Fluid3D([8766,8970,9225,9745],0); -ELEMENTS[12076] = Fluid3D([8766,8970,9745,9046],0); -ELEMENTS[12077] = Fluid3D([8766,8970,9046,8304],0); -ELEMENTS[12078] = Fluid3D([8304,8378,8970,7791],0); -ELEMENTS[12079] = Fluid3D([8378,8766,9225,8658],0); -ELEMENTS[12080] = Fluid3D([6896,6912,6676,6233],0); -ELEMENTS[12081] = Fluid3D([6896,6676,7210,6224],0); -ELEMENTS[12082] = Fluid3D([6912,7515,6676,7166],0); -ELEMENTS[12083] = Fluid3D([6912,7515,7166,7791],0); -ELEMENTS[12084] = Fluid3D([6676,6912,7166,6360],0); -ELEMENTS[12085] = Fluid3D([7515,6676,7166,7320],0); -ELEMENTS[12086] = Fluid3D([6912,7166,6360,6954],0); -ELEMENTS[12087] = Fluid3D([6360,6912,6954,6160],0); -ELEMENTS[12088] = Fluid3D([6912,7166,6954,7791],0); -ELEMENTS[12089] = Fluid3D([7166,6360,6954,6763],0); -ELEMENTS[12090] = Fluid3D([6360,6954,6763,6235],0); -ELEMENTS[12091] = Fluid3D([6763,6360,6235,6001],0); -ELEMENTS[12092] = Fluid3D([7166,6360,6763,6571],0); -ELEMENTS[12093] = Fluid3D([6954,7166,6763,7595],0); -ELEMENTS[12094] = Fluid3D([7166,6360,6571,6676],0); -ELEMENTS[12095] = Fluid3D([6954,7166,7595,7791],0); -ELEMENTS[12096] = Fluid3D([6763,6360,6001,6571],0); -ELEMENTS[12097] = Fluid3D([6360,6954,6235,6160],0); -ELEMENTS[12098] = Fluid3D([6954,6235,6160,6464],0); -ELEMENTS[12099] = Fluid3D([6235,6160,6464,5966],0); -ELEMENTS[12100] = Fluid3D([6235,6160,5966,5591],0); -ELEMENTS[12101] = Fluid3D([6464,6235,5966,6460],0); -ELEMENTS[12102] = Fluid3D([5966,6235,5591,5672],0); -ELEMENTS[12103] = Fluid3D([5966,6235,5672,6212],0); -ELEMENTS[12104] = Fluid3D([5966,6235,6212,6460],0); -ELEMENTS[12105] = Fluid3D([5672,5966,6212,5536],0); -ELEMENTS[12106] = Fluid3D([5672,5966,5536,5447],0); -ELEMENTS[12107] = Fluid3D([5966,5536,5447,5971],0); -ELEMENTS[12108] = Fluid3D([5966,6212,5536,6460],0); -ELEMENTS[12109] = Fluid3D([6235,5672,6212,6001],0); -ELEMENTS[12110] = Fluid3D([6235,5672,6001,5745],0); -ELEMENTS[12111] = Fluid3D([5672,6001,5745,5387],0); -ELEMENTS[12112] = Fluid3D([5672,6001,5387,5633],0); -ELEMENTS[12113] = Fluid3D([5672,6001,5633,6212],0); -ELEMENTS[12114] = Fluid3D([5387,5672,5633,5245],0); -ELEMENTS[12115] = Fluid3D([5745,5672,5387,5591],0); -ELEMENTS[12116] = Fluid3D([5745,5672,5591,6235],0); -ELEMENTS[12117] = Fluid3D([6001,5387,5633,5790],0); -ELEMENTS[12118] = Fluid3D([6001,5745,5387,5747],0); -ELEMENTS[12119] = Fluid3D([5387,5672,5245,5145],0); -ELEMENTS[12120] = Fluid3D([5672,5633,5245,5462],0); -ELEMENTS[12121] = Fluid3D([5633,6001,5790,6149],0); -ELEMENTS[12122] = Fluid3D([5387,5672,5145,5591],0); -ELEMENTS[12123] = Fluid3D([5672,5145,5591,5447],0); -ELEMENTS[12124] = Fluid3D([5672,5633,5462,6212],0); -ELEMENTS[12125] = Fluid3D([6001,5387,5790,5747],0); -ELEMENTS[12126] = Fluid3D([5633,6001,6149,6212],0); -ELEMENTS[12127] = Fluid3D([6001,5745,5747,6360],0); -ELEMENTS[12128] = Fluid3D([6001,5745,6360,6235],0); -ELEMENTS[12129] = Fluid3D([5672,5245,5145,5447],0); -ELEMENTS[12130] = Fluid3D([6001,5790,6149,6571],0); -ELEMENTS[12131] = Fluid3D([5745,5747,6360,6233],0); -ELEMENTS[12132] = Fluid3D([5745,6360,6235,6160],0); -ELEMENTS[12133] = Fluid3D([6235,5745,6160,5591],0); -ELEMENTS[12134] = Fluid3D([5745,6160,5591,5744],0); -ELEMENTS[12135] = Fluid3D([5245,5672,5462,5536],0); -ELEMENTS[12136] = Fluid3D([5672,5462,5536,6212],0); -ELEMENTS[12137] = Fluid3D([5462,5536,6212,5974],0); -ELEMENTS[12138] = Fluid3D([5462,5536,5974,5331],0); -ELEMENTS[12139] = Fluid3D([5462,5536,5331,5039],0); -ELEMENTS[12140] = Fluid3D([5462,5536,5039,5245],0); -ELEMENTS[12141] = Fluid3D([5039,5462,5245,4989],0); -ELEMENTS[12142] = Fluid3D([5245,5039,4989,4584],0); -ELEMENTS[12143] = Fluid3D([5245,5039,4584,4828],0); -ELEMENTS[12144] = Fluid3D([5245,5039,4828,5145],0); -ELEMENTS[12145] = Fluid3D([4828,5245,5145,4792],0); -ELEMENTS[12146] = Fluid3D([5145,4828,4792,4787],0); -ELEMENTS[12147] = Fluid3D([5145,4828,4787,5121],0); -ELEMENTS[12148] = Fluid3D([5145,4828,5121,5447],0); -ELEMENTS[12149] = Fluid3D([5039,4828,5145,5447],0); -ELEMENTS[12150] = Fluid3D([4828,4787,5121,4432],0); -ELEMENTS[12151] = Fluid3D([4828,4792,4787,4328],0); -ELEMENTS[12152] = Fluid3D([4787,5145,5121,5591],0); -ELEMENTS[12153] = Fluid3D([5145,5121,5591,5447],0); -ELEMENTS[12154] = Fluid3D([4792,5145,4787,5171],0); -ELEMENTS[12155] = Fluid3D([4828,4792,4328,4584],0); -ELEMENTS[12156] = Fluid3D([4828,4787,4432,4328],0); -ELEMENTS[12157] = Fluid3D([4432,4828,4328,4584],0); -ELEMENTS[12158] = Fluid3D([5536,5974,5331,5725],0); -ELEMENTS[12159] = Fluid3D([5145,4787,5171,5591],0); -ELEMENTS[12160] = Fluid3D([5121,4828,4432,4768],0); -ELEMENTS[12161] = Fluid3D([5121,4828,4768,5447],0); -ELEMENTS[12162] = Fluid3D([5536,5331,5039,5182],0); -ELEMENTS[12163] = Fluid3D([4787,4432,4328,4184],0); -ELEMENTS[12164] = Fluid3D([4432,4328,4184,3935],0); -ELEMENTS[12165] = Fluid3D([4432,4328,3935,4282],0); -ELEMENTS[12166] = Fluid3D([4432,4328,4282,4584],0); -ELEMENTS[12167] = Fluid3D([5331,5462,5039,4989],0); -ELEMENTS[12168] = Fluid3D([4584,5245,4828,4792],0); -ELEMENTS[12169] = Fluid3D([5331,5536,5725,5182],0); -ELEMENTS[12170] = Fluid3D([5039,4989,4584,4655],0); -ELEMENTS[12171] = Fluid3D([4792,5145,5171,5387],0); -ELEMENTS[12172] = Fluid3D([4792,5145,5387,5245],0); -ELEMENTS[12173] = Fluid3D([5536,5725,5182,5971],0); -ELEMENTS[12174] = Fluid3D([5039,4584,4828,4768],0); -ELEMENTS[12175] = Fluid3D([5536,5974,5725,6460],0); -ELEMENTS[12176] = Fluid3D([5039,5536,5182,5447],0); -ELEMENTS[12177] = Fluid3D([5536,5182,5447,5971],0); -ELEMENTS[12178] = Fluid3D([5039,4989,4655,5331],0); -ELEMENTS[12179] = Fluid3D([4989,5245,4584,4758],0); -ELEMENTS[12180] = Fluid3D([4584,5039,4655,4768],0); -ELEMENTS[12181] = Fluid3D([5974,5462,5331,5603],0); -ELEMENTS[12182] = Fluid3D([5462,5331,5603,4989],0); -ELEMENTS[12183] = Fluid3D([5245,4584,4758,4792],0); -ELEMENTS[12184] = Fluid3D([5725,5331,5182,5179],0); -ELEMENTS[12185] = Fluid3D([5182,5725,5179,5401],0); -ELEMENTS[12186] = Fluid3D([5182,5725,5401,5971],0); -ELEMENTS[12187] = Fluid3D([4989,5245,4758,5633],0); -ELEMENTS[12188] = Fluid3D([4828,4432,4768,4584],0); -ELEMENTS[12189] = Fluid3D([5171,4792,5387,5045],0); -ELEMENTS[12190] = Fluid3D([5145,5171,5387,5591],0); -ELEMENTS[12191] = Fluid3D([5182,5039,5447,4768],0); -ELEMENTS[12192] = Fluid3D([5447,5182,4768,5202],0); -ELEMENTS[12193] = Fluid3D([5447,5182,5202,5971],0); -ELEMENTS[12194] = Fluid3D([5182,4768,5202,4700],0); -ELEMENTS[12195] = Fluid3D([5182,4768,4700,4655],0); -ELEMENTS[12196] = Fluid3D([5202,5182,4700,5401],0); -ELEMENTS[12197] = Fluid3D([5202,5182,5401,5971],0); -ELEMENTS[12198] = Fluid3D([5974,5462,5603,6104],0); -ELEMENTS[12199] = Fluid3D([3935,4432,4282,4110],0); -ELEMENTS[12200] = Fluid3D([4184,4432,3935,4057],0); -ELEMENTS[12201] = Fluid3D([3935,4432,4110,4057],0); -ELEMENTS[12202] = Fluid3D([5974,5462,6104,6212],0); -ELEMENTS[12203] = Fluid3D([4184,4432,4057,4538],0); -ELEMENTS[12204] = Fluid3D([4328,3935,4282,3942],0); -ELEMENTS[12205] = Fluid3D([4282,4328,3942,4584],0); -ELEMENTS[12206] = Fluid3D([4328,3935,3942,3878],0); -ELEMENTS[12207] = Fluid3D([4328,3935,3878,4184],0); -ELEMENTS[12208] = Fluid3D([4792,5387,5045,4991],0); -ELEMENTS[12209] = Fluid3D([4792,5387,4991,5245],0); -ELEMENTS[12210] = Fluid3D([4432,4282,4110,4768],0); -ELEMENTS[12211] = Fluid3D([4828,5039,4768,5447],0); -ELEMENTS[12212] = Fluid3D([5387,5171,5045,5747],0); -ELEMENTS[12213] = Fluid3D([5536,6212,5974,6460],0); -ELEMENTS[12214] = Fluid3D([4432,5121,4768,4641],0); -ELEMENTS[12215] = Fluid3D([5121,4768,4641,5202],0); -ELEMENTS[12216] = Fluid3D([5462,5245,4989,5633],0); -ELEMENTS[12217] = Fluid3D([5462,5603,6104,5526],0); -ELEMENTS[12218] = Fluid3D([5462,5603,5526,4989],0); -ELEMENTS[12219] = Fluid3D([5725,5179,5401,5728],0); -ELEMENTS[12220] = Fluid3D([5401,5725,5728,6066],0); -ELEMENTS[12221] = Fluid3D([5725,5179,5728,5699],0); -ELEMENTS[12222] = Fluid3D([5725,5179,5699,5331],0); -ELEMENTS[12223] = Fluid3D([4328,4787,4184,4375],0); -ELEMENTS[12224] = Fluid3D([4184,4328,4375,3878],0); -ELEMENTS[12225] = Fluid3D([5401,5725,6066,5971],0); -ELEMENTS[12226] = Fluid3D([4787,4432,4184,4538],0); -ELEMENTS[12227] = Fluid3D([5182,5039,4768,4655],0); -ELEMENTS[12228] = Fluid3D([5790,6001,5747,6571],0); -ELEMENTS[12229] = Fluid3D([5039,5536,5447,5245],0); -ELEMENTS[12230] = Fluid3D([5179,5182,5401,4700],0); -ELEMENTS[12231] = Fluid3D([5245,5039,5145,5447],0); -ELEMENTS[12232] = Fluid3D([3942,4328,3878,4170],0); -ELEMENTS[12233] = Fluid3D([5591,5966,5672,5447],0); -ELEMENTS[12234] = Fluid3D([5171,4792,5045,4375],0); -ELEMENTS[12235] = Fluid3D([5728,5401,6066,5741],0); -ELEMENTS[12236] = Fluid3D([5401,6066,5741,5752],0); -ELEMENTS[12237] = Fluid3D([5401,6066,5752,5971],0); -ELEMENTS[12238] = Fluid3D([5728,5401,5741,5206],0); -ELEMENTS[12239] = Fluid3D([5728,5401,5206,5179],0); -ELEMENTS[12240] = Fluid3D([4792,4787,4328,4375],0); -ELEMENTS[12241] = Fluid3D([3935,4282,3942,3788],0); -ELEMENTS[12242] = Fluid3D([4282,3942,3788,4055],0); -ELEMENTS[12243] = Fluid3D([3942,3935,3788,3533],0); -ELEMENTS[12244] = Fluid3D([3942,3935,3533,3878],0); -ELEMENTS[12245] = Fluid3D([4282,3942,4055,4584],0); -ELEMENTS[12246] = Fluid3D([3788,3942,3533,3375],0); -ELEMENTS[12247] = Fluid3D([4328,3878,4170,4375],0); -ELEMENTS[12248] = Fluid3D([5745,5387,5747,5171],0); -ELEMENTS[12249] = Fluid3D([4282,3935,4110,3788],0); -ELEMENTS[12250] = Fluid3D([4989,4584,4655,4421],0); -ELEMENTS[12251] = Fluid3D([4655,4989,4421,4741],0); -ELEMENTS[12252] = Fluid3D([4584,4655,4421,4055],0); -ELEMENTS[12253] = Fluid3D([4421,4655,4741,4251],0); -ELEMENTS[12254] = Fluid3D([4421,4655,4251,4055],0); -ELEMENTS[12255] = Fluid3D([4251,4421,4055,4080],0); -ELEMENTS[12256] = Fluid3D([4421,4055,4080,4166],0); -ELEMENTS[12257] = Fluid3D([4251,4421,4080,4478],0); -ELEMENTS[12258] = Fluid3D([4080,4421,4166,4560],0); -ELEMENTS[12259] = Fluid3D([4080,4421,4560,4478],0); -ELEMENTS[12260] = Fluid3D([4655,4741,4251,4746],0); -ELEMENTS[12261] = Fluid3D([4655,4741,4746,5331],0); -ELEMENTS[12262] = Fluid3D([4655,4989,4741,5331],0); -ELEMENTS[12263] = Fluid3D([4768,4432,4641,4110],0); -ELEMENTS[12264] = Fluid3D([5728,5725,5699,6263],0); -ELEMENTS[12265] = Fluid3D([5728,5725,6263,6066],0); -ELEMENTS[12266] = Fluid3D([5725,5699,6263,5974],0); -ELEMENTS[12267] = Fluid3D([5633,5387,5245,4991],0); -ELEMENTS[12268] = Fluid3D([4768,5202,4700,4641],0); -ELEMENTS[12269] = Fluid3D([5387,5045,4991,5790],0); -ELEMENTS[12270] = Fluid3D([5974,5331,5725,5699],0); -ELEMENTS[12271] = Fluid3D([4432,4057,4538,4641],0); -ELEMENTS[12272] = Fluid3D([5603,6104,5526,5937],0); -ELEMENTS[12273] = Fluid3D([5526,5603,5937,5282],0); -ELEMENTS[12274] = Fluid3D([5526,5603,5282,4989],0); -ELEMENTS[12275] = Fluid3D([3942,3788,4055,3748],0); -ELEMENTS[12276] = Fluid3D([4768,5447,5202,5121],0); -ELEMENTS[12277] = Fluid3D([5387,5633,5790,4991],0); -ELEMENTS[12278] = Fluid3D([5179,5728,5699,5345],0); -ELEMENTS[12279] = Fluid3D([5699,5179,5345,4746],0); -ELEMENTS[12280] = Fluid3D([5179,5728,5345,5206],0); -ELEMENTS[12281] = Fluid3D([4787,4792,5171,4375],0); -ELEMENTS[12282] = Fluid3D([5790,5633,6149,5776],0); -ELEMENTS[12283] = Fluid3D([5633,6149,5776,5526],0); -ELEMENTS[12284] = Fluid3D([5790,5633,5776,4991],0); -ELEMENTS[12285] = Fluid3D([6149,5790,5776,6254],0); -ELEMENTS[12286] = Fluid3D([5776,6149,6254,6514],0); -ELEMENTS[12287] = Fluid3D([5776,6149,6514,6053],0); -ELEMENTS[12288] = Fluid3D([5776,6149,6053,5526],0); -ELEMENTS[12289] = Fluid3D([6053,5776,5526,5729],0); -ELEMENTS[12290] = Fluid3D([5526,6053,5729,5937],0); -ELEMENTS[12291] = Fluid3D([5526,6053,5937,6104],0); -ELEMENTS[12292] = Fluid3D([5526,6053,6104,6149],0); -ELEMENTS[12293] = Fluid3D([6053,5937,6104,6535],0); -ELEMENTS[12294] = Fluid3D([6104,6053,6535,6149],0); -ELEMENTS[12295] = Fluid3D([6053,5937,6535,6255],0); -ELEMENTS[12296] = Fluid3D([6053,5729,5937,6255],0); -ELEMENTS[12297] = Fluid3D([6053,5729,6255,6514],0); -ELEMENTS[12298] = Fluid3D([5729,5937,6255,5529],0); -ELEMENTS[12299] = Fluid3D([6535,6053,6255,6514],0); -ELEMENTS[12300] = Fluid3D([5937,6104,6535,6336],0); -ELEMENTS[12301] = Fluid3D([6104,6535,6336,6838],0); -ELEMENTS[12302] = Fluid3D([6104,6535,6838,6811],0); -ELEMENTS[12303] = Fluid3D([6104,6535,6811,6149],0); -ELEMENTS[12304] = Fluid3D([6838,6104,6811,6212],0); -ELEMENTS[12305] = Fluid3D([6336,6104,6838,5974],0); -ELEMENTS[12306] = Fluid3D([5729,5526,5937,5282],0); -ELEMENTS[12307] = Fluid3D([6535,6838,6811,7378],0); -ELEMENTS[12308] = Fluid3D([6535,6336,6838,7153],0); -ELEMENTS[12309] = Fluid3D([6535,6336,7153,6591],0); -ELEMENTS[12310] = Fluid3D([6535,6336,6591,5937],0); -ELEMENTS[12311] = Fluid3D([6053,5776,5729,6514],0); -ELEMENTS[12312] = Fluid3D([6838,6811,7378,7315],0); -ELEMENTS[12313] = Fluid3D([7153,6535,6591,7274],0); -ELEMENTS[12314] = Fluid3D([7153,6535,7274,7378],0); -ELEMENTS[12315] = Fluid3D([6535,6591,7274,6255],0); -ELEMENTS[12316] = Fluid3D([5937,6104,6336,5603],0); -ELEMENTS[12317] = Fluid3D([5937,6535,6255,6591],0); -ELEMENTS[12318] = Fluid3D([6811,6535,7378,6991],0); -ELEMENTS[12319] = Fluid3D([6811,6535,6991,6514],0); -ELEMENTS[12320] = Fluid3D([6991,6811,6514,7089],0); -ELEMENTS[12321] = Fluid3D([6514,6991,7089,7104],0); -ELEMENTS[12322] = Fluid3D([6514,6991,7104,6801],0); -ELEMENTS[12323] = Fluid3D([6514,6991,6801,6255],0); -ELEMENTS[12324] = Fluid3D([6801,6514,6255,6099],0); -ELEMENTS[12325] = Fluid3D([6255,6801,6099,6118],0); -ELEMENTS[12326] = Fluid3D([6514,6991,6255,6535],0); -ELEMENTS[12327] = Fluid3D([6991,7089,7104,7727],0); -ELEMENTS[12328] = Fluid3D([6991,7104,6801,7632],0); -ELEMENTS[12329] = Fluid3D([6991,7089,7727,7378],0); -ELEMENTS[12330] = Fluid3D([7104,6991,7727,7632],0); -ELEMENTS[12331] = Fluid3D([6991,7727,7632,7378],0); -ELEMENTS[12332] = Fluid3D([7727,7104,7632,8000],0); -ELEMENTS[12333] = Fluid3D([7632,7727,8000,8459],0); -ELEMENTS[12334] = Fluid3D([7632,7727,8459,7894],0); -ELEMENTS[12335] = Fluid3D([7632,7727,7894,7378],0); -ELEMENTS[12336] = Fluid3D([6801,6514,6099,7104],0); -ELEMENTS[12337] = Fluid3D([6801,6991,7632,7274],0); -ELEMENTS[12338] = Fluid3D([6514,6255,6099,5729],0); -ELEMENTS[12339] = Fluid3D([6255,6099,5729,5624],0); -ELEMENTS[12340] = Fluid3D([6099,5729,5624,5162],0); -ELEMENTS[12341] = Fluid3D([6991,6801,6255,7274],0); -ELEMENTS[12342] = Fluid3D([8459,7632,7894,8206],0); -ELEMENTS[12343] = Fluid3D([7727,8459,7894,8399],0); -ELEMENTS[12344] = Fluid3D([8000,7632,8459,8284],0); -ELEMENTS[12345] = Fluid3D([7727,8000,8459,8498],0); -ELEMENTS[12346] = Fluid3D([7727,8459,8399,8498],0); -ELEMENTS[12347] = Fluid3D([7089,6514,7104,6254],0); -ELEMENTS[12348] = Fluid3D([7727,8000,8498,7701],0); -ELEMENTS[12349] = Fluid3D([7727,8000,7701,7104],0); -ELEMENTS[12350] = Fluid3D([8459,7632,8206,8284],0); -ELEMENTS[12351] = Fluid3D([8000,7632,8284,7484],0); -ELEMENTS[12352] = Fluid3D([8000,7632,7484,7104],0); -ELEMENTS[12353] = Fluid3D([7894,7727,8399,7378],0); -ELEMENTS[12354] = Fluid3D([7632,7894,8206,7274],0); -ELEMENTS[12355] = Fluid3D([7632,8284,7484,7594],0); -ELEMENTS[12356] = Fluid3D([6991,6811,7089,7378],0); -ELEMENTS[12357] = Fluid3D([6535,7378,6991,7274],0); -ELEMENTS[12358] = Fluid3D([8459,8000,8284,8909],0); -ELEMENTS[12359] = Fluid3D([8284,8459,8909,9129],0); -ELEMENTS[12360] = Fluid3D([8284,8459,9129,8206],0); -ELEMENTS[12361] = Fluid3D([8000,8284,8909,8322],0); -ELEMENTS[12362] = Fluid3D([8000,8284,8322,7484],0); -ELEMENTS[12363] = Fluid3D([7894,8459,8206,8910],0); -ELEMENTS[12364] = Fluid3D([8206,7894,8910,8148],0); -ELEMENTS[12365] = Fluid3D([8459,8206,8910,9129],0); -ELEMENTS[12366] = Fluid3D([7089,7104,7727,7701],0); -ELEMENTS[12367] = Fluid3D([8206,7894,8148,7274],0); -ELEMENTS[12368] = Fluid3D([7632,8284,7594,8206],0); -ELEMENTS[12369] = Fluid3D([7104,6801,7632,7484],0); -ELEMENTS[12370] = Fluid3D([8000,8498,7701,8402],0); -ELEMENTS[12371] = Fluid3D([7701,8000,8402,7566],0); -ELEMENTS[12372] = Fluid3D([7701,8000,7566,7104],0); -ELEMENTS[12373] = Fluid3D([8000,8498,8402,8909],0); -ELEMENTS[12374] = Fluid3D([8000,8402,7566,8322],0); -ELEMENTS[12375] = Fluid3D([6336,7153,6591,6776],0); -ELEMENTS[12376] = Fluid3D([6591,6336,6776,6038],0); -ELEMENTS[12377] = Fluid3D([6591,6336,6038,5937],0); -ELEMENTS[12378] = Fluid3D([6535,6838,7378,7153],0); -ELEMENTS[12379] = Fluid3D([7484,7632,7594,6801],0); -ELEMENTS[12380] = Fluid3D([8459,7894,8399,8910],0); -ELEMENTS[12381] = Fluid3D([8498,7727,7701,8030],0); -ELEMENTS[12382] = Fluid3D([8498,7727,8030,8399],0); -ELEMENTS[12383] = Fluid3D([7727,7701,8030,7089],0); -ELEMENTS[12384] = Fluid3D([7701,8498,8030,8466],0); -ELEMENTS[12385] = Fluid3D([8498,8030,8466,8871],0); -ELEMENTS[12386] = Fluid3D([8498,8030,8871,8399],0); -ELEMENTS[12387] = Fluid3D([8000,8459,8498,8909],0); -ELEMENTS[12388] = Fluid3D([8284,7484,7594,7943],0); -ELEMENTS[12389] = Fluid3D([7594,8284,7943,8426],0); -ELEMENTS[12390] = Fluid3D([7594,8284,8426,8206],0); -ELEMENTS[12391] = Fluid3D([3935,4184,4057,3743],0); -ELEMENTS[12392] = Fluid3D([3878,3942,4170,3825],0); -ELEMENTS[12393] = Fluid3D([6104,5462,5526,5633],0); -ELEMENTS[12394] = Fluid3D([5462,5526,5633,4989],0); -ELEMENTS[12395] = Fluid3D([4584,4989,4758,4421],0); -ELEMENTS[12396] = Fluid3D([4787,5121,4432,4538],0); -ELEMENTS[12397] = Fluid3D([3942,4328,4170,4584],0); -ELEMENTS[12398] = Fluid3D([5045,4792,4991,4507],0); -ELEMENTS[12399] = Fluid3D([4792,4991,4507,4758],0); -ELEMENTS[12400] = Fluid3D([5045,4792,4507,4375],0); -ELEMENTS[12401] = Fluid3D([4432,5121,4641,4538],0); -ELEMENTS[12402] = Fluid3D([5603,5974,6104,6336],0); -ELEMENTS[12403] = Fluid3D([5331,5182,5179,4655],0); -ELEMENTS[12404] = Fluid3D([5331,5039,5182,4655],0); -ELEMENTS[12405] = Fluid3D([4057,4184,4538,4146],0); -ELEMENTS[12406] = Fluid3D([4184,4538,4146,4561],0); -ELEMENTS[12407] = Fluid3D([4057,4184,4146,3743],0); -ELEMENTS[12408] = Fluid3D([4184,4146,3743,4119],0); -ELEMENTS[12409] = Fluid3D([4146,3743,4119,4004],0); -ELEMENTS[12410] = Fluid3D([4146,3743,4004,4088],0); -ELEMENTS[12411] = Fluid3D([4146,3743,4088,3879],0); -ELEMENTS[12412] = Fluid3D([4088,4146,3879,4538],0); -ELEMENTS[12413] = Fluid3D([4146,3743,3879,4057],0); -ELEMENTS[12414] = Fluid3D([3879,4146,4057,4538],0); -ELEMENTS[12415] = Fluid3D([4004,4146,4088,4561],0); -ELEMENTS[12416] = Fluid3D([3743,4119,4004,3820],0); -ELEMENTS[12417] = Fluid3D([4119,4004,3820,4255],0); -ELEMENTS[12418] = Fluid3D([3743,4119,3820,4184],0); -ELEMENTS[12419] = Fluid3D([4119,4146,4004,4561],0); -ELEMENTS[12420] = Fluid3D([4119,4004,4255,4561],0); -ELEMENTS[12421] = Fluid3D([4088,4146,4538,4561],0); -ELEMENTS[12422] = Fluid3D([4119,4146,4561,4184],0); -ELEMENTS[12423] = Fluid3D([4255,4119,4561,4339],0); -ELEMENTS[12424] = Fluid3D([4119,4561,4339,4375],0); -ELEMENTS[12425] = Fluid3D([5331,5974,5603,5699],0); -ELEMENTS[12426] = Fluid3D([3788,4282,4055,4128],0); -ELEMENTS[12427] = Fluid3D([4282,4055,4128,4655],0); -ELEMENTS[12428] = Fluid3D([6066,5728,5741,6299],0); -ELEMENTS[12429] = Fluid3D([6066,5728,6299,6263],0); -ELEMENTS[12430] = Fluid3D([5728,5741,6299,5778],0); -ELEMENTS[12431] = Fluid3D([5741,6299,5778,6153],0); -ELEMENTS[12432] = Fluid3D([5741,6299,6153,6372],0); -ELEMENTS[12433] = Fluid3D([5741,6299,6372,6066],0); -ELEMENTS[12434] = Fluid3D([5728,5741,5778,5206],0); -ELEMENTS[12435] = Fluid3D([5741,5401,5752,5204],0); -ELEMENTS[12436] = Fluid3D([5741,5401,5204,5206],0); -ELEMENTS[12437] = Fluid3D([5401,5752,5204,5202],0); -ELEMENTS[12438] = Fluid3D([5387,5790,5747,5045],0); -ELEMENTS[12439] = Fluid3D([5752,5741,5204,5733],0); -ELEMENTS[12440] = Fluid3D([5741,5204,5733,5367],0); -ELEMENTS[12441] = Fluid3D([5204,5752,5733,5409],0); -ELEMENTS[12442] = Fluid3D([5733,5741,5367,6153],0); -ELEMENTS[12443] = Fluid3D([5752,5741,5733,6372],0); -ELEMENTS[12444] = Fluid3D([5741,5204,5367,5206],0); -ELEMENTS[12445] = Fluid3D([5204,5752,5409,5202],0); -ELEMENTS[12446] = Fluid3D([5204,5733,5367,5138],0); -ELEMENTS[12447] = Fluid3D([5204,5733,5138,5409],0); -ELEMENTS[12448] = Fluid3D([5367,5204,5138,4806],0); -ELEMENTS[12449] = Fluid3D([5367,5204,4806,5206],0); -ELEMENTS[12450] = Fluid3D([5204,5138,4806,4721],0); -ELEMENTS[12451] = Fluid3D([5204,5138,4721,5409],0); -ELEMENTS[12452] = Fluid3D([4806,5204,4721,4662],0); -ELEMENTS[12453] = Fluid3D([5204,4721,4662,5202],0); -ELEMENTS[12454] = Fluid3D([5733,5367,5138,5622],0); -ELEMENTS[12455] = Fluid3D([5367,5138,5622,4965],0); -ELEMENTS[12456] = Fluid3D([5367,5138,4965,4806],0); -ELEMENTS[12457] = Fluid3D([5733,5367,5622,6153],0); -ELEMENTS[12458] = Fluid3D([4806,5204,4662,5206],0); -ELEMENTS[12459] = Fluid3D([5138,4806,4721,4572],0); -ELEMENTS[12460] = Fluid3D([4806,4721,4572,4267],0); -ELEMENTS[12461] = Fluid3D([5138,4806,4572,4965],0); -ELEMENTS[12462] = Fluid3D([4572,4806,4267,4350],0); -ELEMENTS[12463] = Fluid3D([4806,4267,4350,4361],0); -ELEMENTS[12464] = Fluid3D([4806,4267,4361,4662],0); -ELEMENTS[12465] = Fluid3D([4572,4806,4350,4965],0); -ELEMENTS[12466] = Fluid3D([4721,5138,4572,4765],0); -ELEMENTS[12467] = Fluid3D([4721,5138,4765,5409],0); -ELEMENTS[12468] = Fluid3D([4572,4721,4765,4340],0); -ELEMENTS[12469] = Fluid3D([5138,4572,4765,4975],0); -ELEMENTS[12470] = Fluid3D([4721,4765,4340,4673],0); -ELEMENTS[12471] = Fluid3D([4721,4765,4673,5409],0); -ELEMENTS[12472] = Fluid3D([5138,4572,4975,4965],0); -ELEMENTS[12473] = Fluid3D([4806,4721,4267,4662],0); -ELEMENTS[12474] = Fluid3D([4572,4721,4340,4267],0); -ELEMENTS[12475] = Fluid3D([6954,6763,6235,6934],0); -ELEMENTS[12476] = Fluid3D([6763,6235,6934,6212],0); -ELEMENTS[12477] = Fluid3D([6235,6934,6212,6460],0); -ELEMENTS[12478] = Fluid3D([6934,6212,6460,6838],0); -ELEMENTS[12479] = Fluid3D([6954,6763,6934,7595],0); -ELEMENTS[12480] = Fluid3D([6235,6954,6934,6464],0); -ELEMENTS[12481] = Fluid3D([6676,6912,6360,6233],0); -ELEMENTS[12482] = Fluid3D([7170,6896,7536,7691],0); -ELEMENTS[12483] = Fluid3D([9923,9466,9544,10978],0); -ELEMENTS[12484] = Fluid3D([6346,6739,7170,6528],0); -ELEMENTS[12485] = Fluid3D([7416,7536,8072,8494],0); -ELEMENTS[12486] = Fluid3D([7170,6902,6896,7691],0); -ELEMENTS[12487] = Fluid3D([7675,7416,8181,7512],0); -ELEMENTS[12488] = Fluid3D([7416,8181,7512,8054],0); -ELEMENTS[12489] = Fluid3D([7675,7416,7512,6861],0); -ELEMENTS[12490] = Fluid3D([8181,7675,7512,7961],0); -ELEMENTS[12491] = Fluid3D([7512,8181,7961,7832],0); -ELEMENTS[12492] = Fluid3D([7961,7512,7832,7272],0); -ELEMENTS[12493] = Fluid3D([7961,7512,7272,7193],0); -ELEMENTS[12494] = Fluid3D([7961,7512,7193,7675],0); -ELEMENTS[12495] = Fluid3D([7512,7272,7193,7024],0); -ELEMENTS[12496] = Fluid3D([7512,7193,7675,6861],0); -ELEMENTS[12497] = Fluid3D([7193,7512,7024,6438],0); -ELEMENTS[12498] = Fluid3D([7512,8181,7832,8054],0); -ELEMENTS[12499] = Fluid3D([8181,7961,7832,8567],0); -ELEMENTS[12500] = Fluid3D([7961,7832,8567,8174],0); -ELEMENTS[12501] = Fluid3D([7961,7832,8174,7272],0); -ELEMENTS[12502] = Fluid3D([8567,7961,8174,8919],0); -ELEMENTS[12503] = Fluid3D([8174,8567,8919,9217],0); -ELEMENTS[12504] = Fluid3D([8567,7961,8919,9206],0); -ELEMENTS[12505] = Fluid3D([8919,8567,9206,9510],0); -ELEMENTS[12506] = Fluid3D([8919,8567,9510,9217],0); -ELEMENTS[12507] = Fluid3D([8567,9206,9510,9107],0); -ELEMENTS[12508] = Fluid3D([7832,8567,8174,8568],0); -ELEMENTS[12509] = Fluid3D([7832,8567,8568,9107],0); -ELEMENTS[12510] = Fluid3D([8567,8174,8568,9217],0); -ELEMENTS[12511] = Fluid3D([8174,7832,8568,8299],0); -ELEMENTS[12512] = Fluid3D([8568,8174,8299,9217],0); -ELEMENTS[12513] = Fluid3D([6902,6346,6896,6224],0); -ELEMENTS[12514] = Fluid3D([8072,7536,7791,8784],0); -ELEMENTS[12515] = Fluid3D([7227,6728,7416,6861],0); -ELEMENTS[12516] = Fluid3D([8181,8512,8138,9206],0); -ELEMENTS[12517] = Fluid3D([4059,4589,4215,4141],0); -ELEMENTS[12518] = Fluid3D([5120,4993,5316,5615],0); -ELEMENTS[12519] = Fluid3D([5069,4561,5219,4909],0); -ELEMENTS[12520] = Fluid3D([5069,4561,4909,4339],0); -ELEMENTS[12521] = Fluid3D([4561,5219,4909,4538],0); -ELEMENTS[12522] = Fluid3D([5219,5069,4909,5541],0); -ELEMENTS[12523] = Fluid3D([5069,4909,5541,5234],0); -ELEMENTS[12524] = Fluid3D([5219,5069,5541,5421],0); -ELEMENTS[12525] = Fluid3D([4909,5219,5541,5096],0); -ELEMENTS[12526] = Fluid3D([5541,4909,5096,5171],0); -ELEMENTS[12527] = Fluid3D([5541,4909,5171,5234],0); -ELEMENTS[12528] = Fluid3D([4909,5171,5234,4375],0); -ELEMENTS[12529] = Fluid3D([4909,5096,5171,4787],0); -ELEMENTS[12530] = Fluid3D([5171,4909,4787,4375],0); -ELEMENTS[12531] = Fluid3D([4909,5096,4787,4538],0); -ELEMENTS[12532] = Fluid3D([4909,4787,4375,4184],0); -ELEMENTS[12533] = Fluid3D([5171,5541,5234,5747],0); -ELEMENTS[12534] = Fluid3D([5096,5171,4787,5591],0); -ELEMENTS[12535] = Fluid3D([5096,5171,5591,5744],0); -ELEMENTS[12536] = Fluid3D([5096,5541,5171,5744],0); -ELEMENTS[12537] = Fluid3D([5096,5541,5744,5219],0); -ELEMENTS[12538] = Fluid3D([5541,5744,5219,5421],0); -ELEMENTS[12539] = Fluid3D([4787,5096,5591,5121],0); -ELEMENTS[12540] = Fluid3D([5096,5591,5121,5737],0); -ELEMENTS[12541] = Fluid3D([4787,5096,5121,4538],0); -ELEMENTS[12542] = Fluid3D([5096,5591,5737,5744],0); -ELEMENTS[12543] = Fluid3D([4909,5219,5096,4538],0); -ELEMENTS[12544] = Fluid3D([5541,5069,5234,5663],0); -ELEMENTS[12545] = Fluid3D([5069,4909,5234,4339],0); -ELEMENTS[12546] = Fluid3D([4714,4434,4591,4317],0); -ELEMENTS[12547] = Fluid3D([4512,4881,4999,4558],0); -ELEMENTS[12548] = Fluid3D([4512,4881,4558,4130],0); -ELEMENTS[12549] = Fluid3D([4558,4512,4130,4288],0); -ELEMENTS[12550] = Fluid3D([4130,4558,4288,3893],0); -ELEMENTS[12551] = Fluid3D([4558,4512,4288,4999],0); -ELEMENTS[12552] = Fluid3D([4881,4999,4558,5030],0); -ELEMENTS[12553] = Fluid3D([4558,4881,5030,4684],0); -ELEMENTS[12554] = Fluid3D([4881,5030,4684,5267],0); -ELEMENTS[12555] = Fluid3D([4881,4999,5030,5468],0); -ELEMENTS[12556] = Fluid3D([4558,4881,4684,4130],0); -ELEMENTS[12557] = Fluid3D([4999,4558,5030,5151],0); -ELEMENTS[12558] = Fluid3D([5030,4558,4684,4701],0); -ELEMENTS[12559] = Fluid3D([5030,4558,4701,5151],0); -ELEMENTS[12560] = Fluid3D([4558,4684,4701,4183],0); -ELEMENTS[12561] = Fluid3D([4684,5030,4701,5082],0); -ELEMENTS[12562] = Fluid3D([5030,4701,5082,5370],0); -ELEMENTS[12563] = Fluid3D([4701,5082,5370,4870],0); -ELEMENTS[12564] = Fluid3D([5082,5370,4870,5771],0); -ELEMENTS[12565] = Fluid3D([4701,5082,4870,4610],0); -ELEMENTS[12566] = Fluid3D([5082,4870,4610,5223],0); -ELEMENTS[12567] = Fluid3D([4870,4610,5223,4585],0); -ELEMENTS[12568] = Fluid3D([5082,4870,5223,5771],0); -ELEMENTS[12569] = Fluid3D([4684,5030,5082,5267],0); -ELEMENTS[12570] = Fluid3D([4701,4684,5082,4610],0); -ELEMENTS[12571] = Fluid3D([4512,4591,4120,4207],0); -ELEMENTS[12572] = Fluid3D([4512,4591,4207,4907],0); -ELEMENTS[12573] = Fluid3D([4591,4120,4207,3847],0); -ELEMENTS[12574] = Fluid3D([4120,4512,4207,3999],0); -ELEMENTS[12575] = Fluid3D([4512,4207,3999,4288],0); -ELEMENTS[12576] = Fluid3D([3999,4512,4288,4130],0); -ELEMENTS[12577] = Fluid3D([4288,3999,4130,3668],0); -ELEMENTS[12578] = Fluid3D([3999,4130,3668,3789],0); -ELEMENTS[12579] = Fluid3D([3999,4130,3789,4120],0); -ELEMENTS[12580] = Fluid3D([3668,3999,3789,3594],0); -ELEMENTS[12581] = Fluid3D([3668,3999,3594,3781],0); -ELEMENTS[12582] = Fluid3D([3668,3999,3781,4288],0); -ELEMENTS[12583] = Fluid3D([3999,3789,3594,4120],0); -ELEMENTS[12584] = Fluid3D([3999,3594,3781,4207],0); -ELEMENTS[12585] = Fluid3D([3594,3668,3781,3364],0); -ELEMENTS[12586] = Fluid3D([3668,3781,3364,3642],0); -ELEMENTS[12587] = Fluid3D([3668,3781,3642,4288],0); -ELEMENTS[12588] = Fluid3D([3999,4512,4130,4120],0); -ELEMENTS[12589] = Fluid3D([3594,3668,3364,3335],0); -ELEMENTS[12590] = Fluid3D([3594,3668,3335,3789],0); -ELEMENTS[12591] = Fluid3D([3364,3668,3642,3480],0); -ELEMENTS[12592] = Fluid3D([3668,3364,3335,3480],0); -ELEMENTS[12593] = Fluid3D([3999,3781,4288,4207],0); -ELEMENTS[12594] = Fluid3D([3781,3364,3642,3483],0); -ELEMENTS[12595] = Fluid3D([3642,3781,3483,3922],0); -ELEMENTS[12596] = Fluid3D([3781,3594,3364,3328],0); -ELEMENTS[12597] = Fluid3D([3364,3594,3335,3070],0); -ELEMENTS[12598] = Fluid3D([3483,3642,3922,3820],0); -ELEMENTS[12599] = Fluid3D([3642,3922,3820,4339],0); -ELEMENTS[12600] = Fluid3D([3922,3820,4339,4375],0); -ELEMENTS[12601] = Fluid3D([3642,3781,3922,4288],0); -ELEMENTS[12602] = Fluid3D([3781,3364,3483,3328],0); -ELEMENTS[12603] = Fluid3D([3364,3483,3328,2985],0); -ELEMENTS[12604] = Fluid3D([3781,3483,3922,3610],0); -ELEMENTS[12605] = Fluid3D([3364,3642,3483,3214],0); -ELEMENTS[12606] = Fluid3D([3483,3364,3214,2985],0); -ELEMENTS[12607] = Fluid3D([3364,3642,3214,3480],0); -ELEMENTS[12608] = Fluid3D([4207,4120,3999,3594],0); -ELEMENTS[12609] = Fluid3D([3642,3483,3214,3820],0); -ELEMENTS[12610] = Fluid3D([4512,4999,4907,4288],0); -ELEMENTS[12611] = Fluid3D([4881,4743,5267,4684],0); -ELEMENTS[12612] = Fluid3D([5060,5269,5493,4691],0); -ELEMENTS[12613] = Fluid3D([6254,5776,6514,6099],0); -ELEMENTS[12614] = Fluid3D([12956,12640,12018,12646],0); -ELEMENTS[12615] = Fluid3D([15510,15871,16227,15983],0); -ELEMENTS[12616] = Fluid3D([15871,16227,15983,16231],0); -ELEMENTS[12617] = Fluid3D([16227,15510,15983,15856],0); -ELEMENTS[12618] = Fluid3D([15983,16227,15856,16491],0); -ELEMENTS[12619] = Fluid3D([16227,15510,15856,16000],0); -ELEMENTS[12620] = Fluid3D([15510,15871,15983,15526],0); -ELEMENTS[12621] = Fluid3D([15856,15983,16491,16135],0); -ELEMENTS[12622] = Fluid3D([16491,15856,16135,16447],0); -ELEMENTS[12623] = Fluid3D([15856,15983,16135,15571],0); -ELEMENTS[12624] = Fluid3D([16135,15856,15571,15831],0); -ELEMENTS[12625] = Fluid3D([16135,15856,15831,16447],0); -ELEMENTS[12626] = Fluid3D([16491,15856,16447,16513],0); -ELEMENTS[12627] = Fluid3D([16491,15856,16513,16227],0); -ELEMENTS[12628] = Fluid3D([16447,16491,16513,16954],0); -ELEMENTS[12629] = Fluid3D([15983,16491,16135,16388],0); -ELEMENTS[12630] = Fluid3D([16491,16135,16388,16757],0); -ELEMENTS[12631] = Fluid3D([16135,15983,16388,15822],0); -ELEMENTS[12632] = Fluid3D([15983,16388,15822,15999],0); -ELEMENTS[12633] = Fluid3D([15983,16491,16388,16456],0); -ELEMENTS[12634] = Fluid3D([16491,16388,16456,16871],0); -ELEMENTS[12635] = Fluid3D([16491,16388,16871,16757],0); -ELEMENTS[12636] = Fluid3D([16388,16871,16757,16753],0); -ELEMENTS[12637] = Fluid3D([16757,16388,16753,16699],0); -ELEMENTS[12638] = Fluid3D([16871,16757,16753,17068],0); -ELEMENTS[12639] = Fluid3D([16757,16753,17068,16699],0); -ELEMENTS[12640] = Fluid3D([16753,17068,16699,16580],0); -ELEMENTS[12641] = Fluid3D([16388,16871,16753,16456],0); -ELEMENTS[12642] = Fluid3D([15983,16491,16456,16227],0); -ELEMENTS[12643] = Fluid3D([16135,15983,15822,15571],0); -ELEMENTS[12644] = Fluid3D([15856,15983,15571,15510],0); -ELEMENTS[12645] = Fluid3D([16388,16135,15822,16268],0); -ELEMENTS[12646] = Fluid3D([16388,16135,16268,16757],0); -ELEMENTS[12647] = Fluid3D([16268,16388,16757,16699],0); -ELEMENTS[12648] = Fluid3D([15822,16388,16268,16207],0); -ELEMENTS[12649] = Fluid3D([15822,16388,16207,15999],0); -ELEMENTS[12650] = Fluid3D([16135,15822,16268,15563],0); -ELEMENTS[12651] = Fluid3D([16268,15822,16207,15563],0); -ELEMENTS[12652] = Fluid3D([16388,16268,16207,16699],0); -ELEMENTS[12653] = Fluid3D([15571,16135,15831,15281],0); -ELEMENTS[12654] = Fluid3D([16135,16491,16447,16680],0); -ELEMENTS[12655] = Fluid3D([16135,16491,16680,16757],0); -ELEMENTS[12656] = Fluid3D([16491,16447,16680,16954],0); -ELEMENTS[12657] = Fluid3D([16447,16135,16680,16360],0); -ELEMENTS[12658] = Fluid3D([16135,16680,16360,16268],0); -ELEMENTS[12659] = Fluid3D([16447,16135,16360,15831],0); -ELEMENTS[12660] = Fluid3D([16680,16447,16360,16843],0); -ELEMENTS[12661] = Fluid3D([16447,16360,16843,16429],0); -ELEMENTS[12662] = Fluid3D([16360,16843,16429,16707],0); -ELEMENTS[12663] = Fluid3D([16843,16429,16707,16904],0); -ELEMENTS[12664] = Fluid3D([16429,16707,16904,16589],0); -ELEMENTS[12665] = Fluid3D([16429,16707,16589,16109],0); -ELEMENTS[12666] = Fluid3D([16429,16707,16109,16360],0); -ELEMENTS[12667] = Fluid3D([16680,16447,16843,16954],0); -ELEMENTS[12668] = Fluid3D([16447,16843,16954,16609],0); -ELEMENTS[12669] = Fluid3D([16954,16447,16609,16513],0); -ELEMENTS[12670] = Fluid3D([16447,16609,16513,15842],0); -ELEMENTS[12671] = Fluid3D([16609,16954,16513,16949],0); -ELEMENTS[12672] = Fluid3D([16513,16609,16949,16834],0); -ELEMENTS[12673] = Fluid3D([16954,16513,16949,16893],0); -ELEMENTS[12674] = Fluid3D([16513,16949,16893,16947],0); -ELEMENTS[12675] = Fluid3D([16949,16893,16947,17264],0); -ELEMENTS[12676] = Fluid3D([16949,16954,16893,17354],0); -ELEMENTS[12677] = Fluid3D([16843,16429,16904,16815],0); -ELEMENTS[12678] = Fluid3D([16429,16904,16815,16602],0); -ELEMENTS[12679] = Fluid3D([16904,16843,16815,17215],0); -ELEMENTS[12680] = Fluid3D([16843,16429,16815,16609],0); -ELEMENTS[12681] = Fluid3D([16429,16815,16609,16260],0); -ELEMENTS[12682] = Fluid3D([16815,16609,16260,16834],0); -ELEMENTS[12683] = Fluid3D([16815,16609,16834,17078],0); -ELEMENTS[12684] = Fluid3D([16815,16609,17078,16954],0); -ELEMENTS[12685] = Fluid3D([16815,16609,16954,16843],0); -ELEMENTS[12686] = Fluid3D([17078,16815,16954,17215],0); -ELEMENTS[12687] = Fluid3D([17078,16815,17215,17100],0); -ELEMENTS[12688] = Fluid3D([17078,16815,17100,16834],0); -ELEMENTS[12689] = Fluid3D([17215,17078,17100,17510],0); -ELEMENTS[12690] = Fluid3D([16954,16815,16843,17215],0); -ELEMENTS[12691] = Fluid3D([16815,17215,17100,16904],0); -ELEMENTS[12692] = Fluid3D([17100,16815,16904,16602],0); -ELEMENTS[12693] = Fluid3D([16904,16843,17215,17159],0); -ELEMENTS[12694] = Fluid3D([16815,16429,16602,16260],0); -ELEMENTS[12695] = Fluid3D([16843,17215,17159,17241],0); -ELEMENTS[12696] = Fluid3D([17215,17159,17241,17695],0); -ELEMENTS[12697] = Fluid3D([16843,17215,17241,16954],0); -ELEMENTS[12698] = Fluid3D([17100,16815,16602,16781],0); -ELEMENTS[12699] = Fluid3D([17100,16815,16781,16834],0); -ELEMENTS[12700] = Fluid3D([16815,16602,16781,16260],0); -ELEMENTS[12701] = Fluid3D([16815,16781,16834,16260],0); -ELEMENTS[12702] = Fluid3D([16707,16904,16589,17133],0); -ELEMENTS[12703] = Fluid3D([16360,16843,16707,17012],0); -ELEMENTS[12704] = Fluid3D([16429,16904,16602,16589],0); -ELEMENTS[12705] = Fluid3D([16707,16843,16904,17159],0); -ELEMENTS[12706] = Fluid3D([16843,16447,16429,16609],0); -ELEMENTS[12707] = Fluid3D([17159,16843,17241,17012],0); -ELEMENTS[12708] = Fluid3D([16360,16680,16843,17012],0); -ELEMENTS[12709] = Fluid3D([16447,16360,16429,15831],0); -ELEMENTS[12710] = Fluid3D([16707,16589,16109,16467],0); -ELEMENTS[12711] = Fluid3D([16707,16589,16467,16840],0); -ELEMENTS[12712] = Fluid3D([16589,16109,16467,16008],0); -ELEMENTS[12713] = Fluid3D([16109,16467,16008,15830],0); -ELEMENTS[12714] = Fluid3D([16467,16008,15830,15987],0); -ELEMENTS[12715] = Fluid3D([16467,16008,15987,16476],0); -ELEMENTS[12716] = Fluid3D([16467,16008,16476,16589],0); -ELEMENTS[12717] = Fluid3D([16589,16467,16840,16476],0); -ELEMENTS[12718] = Fluid3D([16008,15987,16476,16017],0); -ELEMENTS[12719] = Fluid3D([16476,16008,16017,16257],0); -ELEMENTS[12720] = Fluid3D([16008,16017,16257,15502],0); -ELEMENTS[12721] = Fluid3D([16008,15987,16017,15499],0); -ELEMENTS[12722] = Fluid3D([16017,16008,15499,15502],0); -ELEMENTS[12723] = Fluid3D([16017,16476,16257,16480],0); -ELEMENTS[12724] = Fluid3D([15987,16476,16017,16566],0); -ELEMENTS[12725] = Fluid3D([15987,16476,16566,16907],0); -ELEMENTS[12726] = Fluid3D([15987,16017,15499,15352],0); -ELEMENTS[12727] = Fluid3D([16476,16566,16907,16824],0); -ELEMENTS[12728] = Fluid3D([16476,16566,16824,16480],0); -ELEMENTS[12729] = Fluid3D([16907,16476,16824,16840],0); -ELEMENTS[12730] = Fluid3D([16907,16476,16840,16467],0); -ELEMENTS[12731] = Fluid3D([16840,16907,16467,16896],0); -ELEMENTS[12732] = Fluid3D([16840,16907,16896,17211],0); -ELEMENTS[12733] = Fluid3D([16896,16840,17211,16707],0); -ELEMENTS[12734] = Fluid3D([16840,16907,17211,17133],0); -ELEMENTS[12735] = Fluid3D([16840,16907,17133,16824],0); -ELEMENTS[12736] = Fluid3D([17211,16840,17133,16707],0); -ELEMENTS[12737] = Fluid3D([16907,16896,17211,16995],0); -ELEMENTS[12738] = Fluid3D([16896,17211,16995,17295],0); -ELEMENTS[12739] = Fluid3D([16907,16896,16995,16455],0); -ELEMENTS[12740] = Fluid3D([16896,16995,16455,16799],0); -ELEMENTS[12741] = Fluid3D([16896,16995,16799,17295],0); -ELEMENTS[12742] = Fluid3D([16455,16896,16799,16467],0); -ELEMENTS[12743] = Fluid3D([16455,16896,16467,16907],0); -ELEMENTS[12744] = Fluid3D([17133,16840,16824,16589],0); -ELEMENTS[12745] = Fluid3D([16995,16455,16799,16762],0); -ELEMENTS[12746] = Fluid3D([16476,16008,16257,16589],0); -ELEMENTS[12747] = Fluid3D([16008,15987,15499,15830],0); -ELEMENTS[12748] = Fluid3D([15499,16008,15830,15486],0); -ELEMENTS[12749] = Fluid3D([15499,16008,15486,15502],0); -ELEMENTS[12750] = Fluid3D([16008,16257,16589,15992],0); -ELEMENTS[12751] = Fluid3D([16008,16257,15992,15502],0); -ELEMENTS[12752] = Fluid3D([15499,15987,15352,15830],0); -ELEMENTS[12753] = Fluid3D([16467,16840,16896,16707],0); -ELEMENTS[12754] = Fluid3D([16008,15830,15486,16109],0); -ELEMENTS[12755] = Fluid3D([16589,16008,15992,16109],0); -ELEMENTS[12756] = Fluid3D([15830,15499,15486,15171],0); -ELEMENTS[12757] = Fluid3D([15499,15486,15171,14952],0); -ELEMENTS[12758] = Fluid3D([15486,15171,14952,14832],0); -ELEMENTS[12759] = Fluid3D([15499,15486,14952,15502],0); -ELEMENTS[12760] = Fluid3D([15171,15499,14952,15352],0); -ELEMENTS[12761] = Fluid3D([15171,15499,15352,15830],0); -ELEMENTS[12762] = Fluid3D([16467,16455,16907,15987],0); -ELEMENTS[12763] = Fluid3D([16467,16455,15987,15830],0); -ELEMENTS[12764] = Fluid3D([15486,15830,15171,15238],0); -ELEMENTS[12765] = Fluid3D([15171,15486,15238,14832],0); -ELEMENTS[12766] = Fluid3D([15830,15171,15238,15577],0); -ELEMENTS[12767] = Fluid3D([15171,15238,15577,14747],0); -ELEMENTS[12768] = Fluid3D([15171,15238,14747,14455],0); -ELEMENTS[12769] = Fluid3D([14747,15171,14455,14655],0); -ELEMENTS[12770] = Fluid3D([15577,15171,14747,14948],0); -ELEMENTS[12771] = Fluid3D([15577,15171,14948,15614],0); -ELEMENTS[12772] = Fluid3D([15171,15238,14455,14832],0); -ELEMENTS[12773] = Fluid3D([15577,15171,15614,15830],0); -ELEMENTS[12774] = Fluid3D([15171,15614,15830,15352],0); -ELEMENTS[12775] = Fluid3D([15614,15577,15830,16071],0); -ELEMENTS[12776] = Fluid3D([15830,15614,16071,15987],0); -ELEMENTS[12777] = Fluid3D([15830,15614,15987,15352],0); -ELEMENTS[12778] = Fluid3D([15171,14747,14948,14655],0); -ELEMENTS[12779] = Fluid3D([14948,15171,14655,15352],0); -ELEMENTS[12780] = Fluid3D([14655,14948,15352,14708],0); -ELEMENTS[12781] = Fluid3D([15238,14747,14455,14640],0); -ELEMENTS[12782] = Fluid3D([15171,15614,15352,14948],0); -ELEMENTS[12783] = Fluid3D([15614,15352,14948,15431],0); -ELEMENTS[12784] = Fluid3D([15614,15352,15431,15987],0); -ELEMENTS[12785] = Fluid3D([14747,14455,14640,13825],0); -ELEMENTS[12786] = Fluid3D([14747,14948,14655,14265],0); -ELEMENTS[12787] = Fluid3D([14948,14655,14265,14201],0); -ELEMENTS[12788] = Fluid3D([14655,14265,14201,13860],0); -ELEMENTS[12789] = Fluid3D([14265,14201,13860,13399],0); -ELEMENTS[12790] = Fluid3D([14265,14948,14201,14362],0); -ELEMENTS[12791] = Fluid3D([14201,14265,14362,13399],0); -ELEMENTS[12792] = Fluid3D([14265,14948,14362,14839],0); -ELEMENTS[12793] = Fluid3D([14362,14265,14839,14055],0); -ELEMENTS[12794] = Fluid3D([14362,14265,14055,13399],0); -ELEMENTS[12795] = Fluid3D([14265,14948,14839,14747],0); -ELEMENTS[12796] = Fluid3D([14655,14265,13860,14747],0); -ELEMENTS[12797] = Fluid3D([14265,14839,14055,14510],0); -ELEMENTS[12798] = Fluid3D([15614,15577,16071,15590],0); -ELEMENTS[12799] = Fluid3D([16071,15614,15590,16033],0); -ELEMENTS[12800] = Fluid3D([16071,15614,16033,15987],0); -ELEMENTS[12801] = Fluid3D([15614,15590,16033,15431],0); -ELEMENTS[12802] = Fluid3D([15614,15590,15431,14948],0); -ELEMENTS[12803] = Fluid3D([15590,16033,15431,15763],0); -ELEMENTS[12804] = Fluid3D([16033,15614,15431,15987],0); -ELEMENTS[12805] = Fluid3D([15431,15590,15763,15013],0); -ELEMENTS[12806] = Fluid3D([15431,15590,15013,14948],0); -ELEMENTS[12807] = Fluid3D([16033,15431,15763,16048],0); -ELEMENTS[12808] = Fluid3D([15763,15431,15013,15332],0); -ELEMENTS[12809] = Fluid3D([15763,15431,15332,16048],0); -ELEMENTS[12810] = Fluid3D([15431,15013,15332,14702],0); -ELEMENTS[12811] = Fluid3D([15238,15577,14747,15219],0); -ELEMENTS[12812] = Fluid3D([14948,14839,14747,15577],0); -ELEMENTS[12813] = Fluid3D([15590,15763,15013,15574],0); -ELEMENTS[12814] = Fluid3D([15013,15590,15574,14839],0); -ELEMENTS[12815] = Fluid3D([14948,14655,14201,14708],0); -ELEMENTS[12816] = Fluid3D([15614,15577,15590,14948],0); -ELEMENTS[12817] = Fluid3D([15590,15763,15574,16160],0); -ELEMENTS[12818] = Fluid3D([14839,14362,14055,14667],0); -ELEMENTS[12819] = Fluid3D([14362,14055,14667,14172],0); -ELEMENTS[12820] = Fluid3D([14362,14055,14172,13617],0); -ELEMENTS[12821] = Fluid3D([14667,14362,14172,15013],0); -ELEMENTS[12822] = Fluid3D([14667,14362,15013,14839],0); -ELEMENTS[12823] = Fluid3D([14055,14667,14172,14044],0); -ELEMENTS[12824] = Fluid3D([14055,14667,14044,14389],0); -ELEMENTS[12825] = Fluid3D([14055,14667,14389,14839],0); -ELEMENTS[12826] = Fluid3D([15763,15574,16160,16050],0); -ELEMENTS[12827] = Fluid3D([16160,15763,16050,16420],0); -ELEMENTS[12828] = Fluid3D([15590,16071,16033,16160],0); -ELEMENTS[12829] = Fluid3D([14172,14055,14044,13495],0); -ELEMENTS[12830] = Fluid3D([14044,14172,13495,13419],0); -ELEMENTS[12831] = Fluid3D([14172,14055,13495,13617],0); -ELEMENTS[12832] = Fluid3D([13495,14172,13617,14024],0); -ELEMENTS[12833] = Fluid3D([13495,14172,14024,13419],0); -ELEMENTS[12834] = Fluid3D([14172,13617,14024,14623],0); -ELEMENTS[12835] = Fluid3D([14024,14172,14623,14753],0); -ELEMENTS[12836] = Fluid3D([14024,14172,14753,14207],0); -ELEMENTS[12837] = Fluid3D([14024,14172,14207,13419],0); -ELEMENTS[12838] = Fluid3D([14753,14024,14207,14353],0); -ELEMENTS[12839] = Fluid3D([14623,14024,14753,14461],0); -ELEMENTS[12840] = Fluid3D([14172,14753,14207,14667],0); -ELEMENTS[12841] = Fluid3D([14172,14623,14753,15013],0); -ELEMENTS[12842] = Fluid3D([14753,14024,14353,14461],0); -ELEMENTS[12843] = Fluid3D([14024,14207,14353,13419],0); -ELEMENTS[12844] = Fluid3D([13617,14024,14623,13733],0); -ELEMENTS[12845] = Fluid3D([14207,14753,14353,14901],0); -ELEMENTS[12846] = Fluid3D([14753,14353,14901,15122],0); -ELEMENTS[12847] = Fluid3D([14753,14353,15122,14894],0); -ELEMENTS[12848] = Fluid3D([14753,14353,14894,14461],0); -ELEMENTS[12849] = Fluid3D([14353,14901,15122,14843],0); -ELEMENTS[12850] = Fluid3D([14353,14901,14843,14135],0); -ELEMENTS[12851] = Fluid3D([14353,14901,14135,14207],0); -ELEMENTS[12852] = Fluid3D([14353,15122,14894,14674],0); -ELEMENTS[12853] = Fluid3D([15122,14353,14843,14674],0); -ELEMENTS[12854] = Fluid3D([14894,14353,14674,14461],0); -ELEMENTS[12855] = Fluid3D([15763,15013,15574,15496],0); -ELEMENTS[12856] = Fluid3D([15013,15574,15496,14753],0); -ELEMENTS[12857] = Fluid3D([14901,14753,15122,15445],0); -ELEMENTS[12858] = Fluid3D([14753,15122,15445,15496],0); -ELEMENTS[12859] = Fluid3D([15445,14753,15496,15574],0); -ELEMENTS[12860] = Fluid3D([15496,15445,15574,16050],0); -ELEMENTS[12861] = Fluid3D([14843,14353,14135,14148],0); -ELEMENTS[12862] = Fluid3D([14843,14353,14148,14674],0); -ELEMENTS[12863] = Fluid3D([15574,15590,16160,15892],0); -ELEMENTS[12864] = Fluid3D([15574,15590,15892,14839],0); -ELEMENTS[12865] = Fluid3D([15590,16160,15892,16071],0); -ELEMENTS[12866] = Fluid3D([14839,14265,14747,14510],0); -ELEMENTS[12867] = Fluid3D([14747,14839,14510,15223],0); -ELEMENTS[12868] = Fluid3D([14510,14747,15223,15219],0); -ELEMENTS[12869] = Fluid3D([14839,14510,15223,14956],0); -ELEMENTS[12870] = Fluid3D([14747,14839,15223,15577],0); -ELEMENTS[12871] = Fluid3D([15223,14747,15577,15219],0); -ELEMENTS[12872] = Fluid3D([14839,15223,15577,15892],0); -ELEMENTS[12873] = Fluid3D([15013,15763,15332,15496],0); -ELEMENTS[12874] = Fluid3D([15122,14753,14894,15496],0); -ELEMENTS[12875] = Fluid3D([15590,15763,16160,16033],0); -ELEMENTS[12876] = Fluid3D([14044,14055,14389,13686],0); -ELEMENTS[12877] = Fluid3D([14044,14055,13686,13495],0); -ELEMENTS[12878] = Fluid3D([14055,14389,13686,13892],0); -ELEMENTS[12879] = Fluid3D([13686,14055,13892,13399],0); -ELEMENTS[12880] = Fluid3D([14389,14044,13686,13765],0); -ELEMENTS[12881] = Fluid3D([13686,14055,13399,13495],0); -ELEMENTS[12882] = Fluid3D([13686,14044,13495,13246],0); -ELEMENTS[12883] = Fluid3D([13686,14044,13246,13765],0); -ELEMENTS[12884] = Fluid3D([14389,13686,13892,13765],0); -ELEMENTS[12885] = Fluid3D([14055,14389,13892,14510],0); -ELEMENTS[12886] = Fluid3D([14055,13399,13495,13617],0); -ELEMENTS[12887] = Fluid3D([14207,14753,14901,14801],0); -ELEMENTS[12888] = Fluid3D([14207,14753,14801,14667],0); -ELEMENTS[12889] = Fluid3D([14753,14801,14667,15574],0); -ELEMENTS[12890] = Fluid3D([16824,16476,16480,16257],0); -ELEMENTS[12891] = Fluid3D([14667,14172,14044,14207],0); -ELEMENTS[12892] = Fluid3D([14172,14044,14207,13419],0); -ELEMENTS[12893] = Fluid3D([14044,13495,13246,13419],0); -ELEMENTS[12894] = Fluid3D([14901,14843,14135,14966],0); -ELEMENTS[12895] = Fluid3D([14135,14901,14966,14494],0); -ELEMENTS[12896] = Fluid3D([14901,14843,14966,15468],0); -ELEMENTS[12897] = Fluid3D([14901,14843,15468,15122],0); -ELEMENTS[12898] = Fluid3D([14966,14135,14494,14305],0); -ELEMENTS[12899] = Fluid3D([14135,14494,14305,13844],0); -ELEMENTS[12900] = Fluid3D([14135,14494,13844,14207],0); -ELEMENTS[12901] = Fluid3D([14966,14135,14305,14440],0); -ELEMENTS[12902] = Fluid3D([14966,14135,14440,14843],0); -ELEMENTS[12903] = Fluid3D([14135,14305,14440,13644],0); -ELEMENTS[12904] = Fluid3D([14135,14305,13644,13844],0); -ELEMENTS[12905] = Fluid3D([14440,14135,13644,14148],0); -ELEMENTS[12906] = Fluid3D([14135,14901,14494,14207],0); -ELEMENTS[12907] = Fluid3D([14305,14440,13644,14031],0); -ELEMENTS[12908] = Fluid3D([14305,14440,14031,14971],0); -ELEMENTS[12909] = Fluid3D([14440,13644,14031,13702],0); -ELEMENTS[12910] = Fluid3D([13644,14031,13702,13199],0); -ELEMENTS[12911] = Fluid3D([13644,14031,13199,13462],0); -ELEMENTS[12912] = Fluid3D([13644,14031,13462,14305],0); -ELEMENTS[12913] = Fluid3D([14440,13644,13702,14148],0); -ELEMENTS[12914] = Fluid3D([14305,14440,14971,14966],0); -ELEMENTS[12915] = Fluid3D([14971,14305,14966,14963],0); -ELEMENTS[12916] = Fluid3D([14966,14971,14963,15371],0); -ELEMENTS[12917] = Fluid3D([14971,14963,15371,14976],0); -ELEMENTS[12918] = Fluid3D([14971,14305,14963,14976],0); -ELEMENTS[12919] = Fluid3D([14440,14971,14966,15191],0); -ELEMENTS[12920] = Fluid3D([14971,14966,15191,15798],0); -ELEMENTS[12921] = Fluid3D([14971,14966,15798,15371],0); -ELEMENTS[12922] = Fluid3D([15798,14971,15371,15467],0); -ELEMENTS[12923] = Fluid3D([14966,15191,15798,15468],0); -ELEMENTS[12924] = Fluid3D([15191,14971,15798,15467],0); -ELEMENTS[12925] = Fluid3D([14305,14966,14963,14494],0); -ELEMENTS[12926] = Fluid3D([14966,14963,14494,15252],0); -ELEMENTS[12927] = Fluid3D([14963,14494,15252,14985],0); -ELEMENTS[12928] = Fluid3D([14963,14494,14985,14336],0); -ELEMENTS[12929] = Fluid3D([14963,14494,14336,14305],0); -ELEMENTS[12930] = Fluid3D([15252,14963,14985,15479],0); -ELEMENTS[12931] = Fluid3D([14985,14963,14336,15003],0); -ELEMENTS[12932] = Fluid3D([14494,14985,14336,14334],0); -ELEMENTS[12933] = Fluid3D([14966,14963,15252,15371],0); -ELEMENTS[12934] = Fluid3D([15252,14963,15479,15371],0); -ELEMENTS[12935] = Fluid3D([14963,15479,15371,15003],0); -ELEMENTS[12936] = Fluid3D([14985,14963,15003,15479],0); -ELEMENTS[12937] = Fluid3D([14494,14985,14334,14801],0); -ELEMENTS[12938] = Fluid3D([14494,15252,14985,14801],0); -ELEMENTS[12939] = Fluid3D([14963,14336,15003,14651],0); -ELEMENTS[12940] = Fluid3D([14963,14336,14651,14305],0); -ELEMENTS[12941] = Fluid3D([14336,14494,14334,13844],0); -ELEMENTS[12942] = Fluid3D([15003,14963,14651,14976],0); -ELEMENTS[12943] = Fluid3D([14494,14966,15252,14901],0); -ELEMENTS[12944] = Fluid3D([15252,14494,14901,14801],0); -ELEMENTS[12945] = Fluid3D([14966,14440,15191,14843],0); -ELEMENTS[12946] = Fluid3D([14985,14336,14334,14216],0); -ELEMENTS[12947] = Fluid3D([14985,15252,15479,15611],0); -ELEMENTS[12948] = Fluid3D([15252,15479,15611,15965],0); -ELEMENTS[12949] = Fluid3D([15252,15479,15965,15798],0); -ELEMENTS[12950] = Fluid3D([15479,14985,15611,15284],0); -ELEMENTS[12951] = Fluid3D([14966,15252,14901,15468],0); -ELEMENTS[12952] = Fluid3D([15371,15798,15467,16014],0); -ELEMENTS[12953] = Fluid3D([15371,15798,16014,15479],0); -ELEMENTS[12954] = Fluid3D([14336,15003,14651,14498],0); -ELEMENTS[12955] = Fluid3D([14336,15003,14498,14985],0); -ELEMENTS[12956] = Fluid3D([15479,15611,15965,16097],0); -ELEMENTS[12957] = Fluid3D([15479,15611,16097,15284],0); -ELEMENTS[12958] = Fluid3D([15965,15479,16097,16132],0); -ELEMENTS[12959] = Fluid3D([15965,15479,16132,15798],0); -ELEMENTS[12960] = Fluid3D([15611,15252,15965,15718],0); -ELEMENTS[12961] = Fluid3D([16097,15965,16132,16498],0); -ELEMENTS[12962] = Fluid3D([16097,15965,16498,16266],0); -ELEMENTS[12963] = Fluid3D([16097,15965,16266,15611],0); -ELEMENTS[12964] = Fluid3D([15003,14985,15479,15284],0); -ELEMENTS[12965] = Fluid3D([15003,14985,15284,14498],0); -ELEMENTS[12966] = Fluid3D([15284,15003,14498,15245],0); -ELEMENTS[12967] = Fluid3D([15467,15371,16014,15731],0); -ELEMENTS[12968] = Fluid3D([14985,15252,15611,14801],0); -ELEMENTS[12969] = Fluid3D([14667,14044,14389,14770],0); -ELEMENTS[12970] = Fluid3D([14389,14667,14770,15184],0); -ELEMENTS[12971] = Fluid3D([14667,14044,14770,14801],0); -ELEMENTS[12972] = Fluid3D([14770,14667,14801,15184],0); -ELEMENTS[12973] = Fluid3D([14667,14044,14801,14207],0); -ELEMENTS[12974] = Fluid3D([14044,14770,14801,14334],0); -ELEMENTS[12975] = Fluid3D([14044,14770,14334,14389],0); -ELEMENTS[12976] = Fluid3D([14770,14801,14334,14985],0); -ELEMENTS[12977] = Fluid3D([14334,14770,14985,14216],0); -ELEMENTS[12978] = Fluid3D([14389,14667,15184,14839],0); -ELEMENTS[12979] = Fluid3D([15122,14901,15445,15468],0); -ELEMENTS[12980] = Fluid3D([16109,16467,15830,16189],0); -ELEMENTS[12981] = Fluid3D([16109,16467,16189,16707],0); -ELEMENTS[12982] = Fluid3D([16467,15830,16189,16799],0); -ELEMENTS[12983] = Fluid3D([15830,16109,16189,15693],0); -ELEMENTS[12984] = Fluid3D([16109,16189,15693,16360],0); -ELEMENTS[12985] = Fluid3D([15830,16109,15693,15486],0); -ELEMENTS[12986] = Fluid3D([16189,15830,15693,15577],0); -ELEMENTS[12987] = Fluid3D([15965,15611,15718,16266],0); -ELEMENTS[12988] = Fluid3D([14843,14966,15468,15191],0); -ELEMENTS[12989] = Fluid3D([15574,15763,15496,16050],0); -ELEMENTS[12990] = Fluid3D([15574,16160,16050,16152],0); -ELEMENTS[12991] = Fluid3D([16160,16050,16152,16532],0); -ELEMENTS[12992] = Fluid3D([16160,16050,16532,16420],0); -ELEMENTS[12993] = Fluid3D([15574,16160,16152,15892],0); -ELEMENTS[12994] = Fluid3D([16050,15574,16152,15718],0); -ELEMENTS[12995] = Fluid3D([15122,14894,14674,15079],0); -ELEMENTS[12996] = Fluid3D([14674,15122,15079,15659],0); -ELEMENTS[12997] = Fluid3D([14894,14674,15079,14461],0); -ELEMENTS[12998] = Fluid3D([15122,14894,15079,15496],0); -ELEMENTS[12999] = Fluid3D([14135,14843,14148,14440],0); -ELEMENTS[13000] = Fluid3D([16707,16589,16840,17133],0); -ELEMENTS[13001] = Fluid3D([14753,14901,14801,15445],0); -ELEMENTS[13002] = Fluid3D([17215,16904,17159,17422],0); -ELEMENTS[13003] = Fluid3D([17159,17215,17422,17695],0); -ELEMENTS[13004] = Fluid3D([15856,16447,16513,15842],0); -ELEMENTS[13005] = Fluid3D([16456,16491,16871,16893],0); -ELEMENTS[13006] = Fluid3D([15987,16467,16476,16907],0); -ELEMENTS[13007] = Fluid3D([14353,14135,14148,13419],0); -ELEMENTS[13008] = Fluid3D([16388,15983,16456,15999],0); -ELEMENTS[13009] = Fluid3D([15856,15571,15831,15020],0); -ELEMENTS[13010] = Fluid3D([15571,15831,15020,15281],0); -ELEMENTS[13011] = Fluid3D([16589,16429,16109,15992],0); -ELEMENTS[13012] = Fluid3D([14031,13199,13462,13488],0); -ELEMENTS[13013] = Fluid3D([13462,14031,13488,14143],0); -ELEMENTS[13014] = Fluid3D([14031,13199,13488,13703],0); -ELEMENTS[13015] = Fluid3D([14031,13199,13703,13702],0); -ELEMENTS[13016] = Fluid3D([14031,13488,14143,14302],0); -ELEMENTS[13017] = Fluid3D([14031,13488,14302,13703],0); -ELEMENTS[13018] = Fluid3D([13199,13488,13703,12818],0); -ELEMENTS[13019] = Fluid3D([13703,13199,12818,12978],0); -ELEMENTS[13020] = Fluid3D([13488,14143,14302,13857],0); -ELEMENTS[13021] = Fluid3D([12818,13703,12978,13164],0); -ELEMENTS[13022] = Fluid3D([12818,13703,13164,13503],0); -ELEMENTS[13023] = Fluid3D([12818,13703,13503,13488],0); -ELEMENTS[13024] = Fluid3D([13488,14143,13857,13460],0); -ELEMENTS[13025] = Fluid3D([13857,13488,13460,13043],0); -ELEMENTS[13026] = Fluid3D([13857,13488,13043,13503],0); -ELEMENTS[13027] = Fluid3D([13488,14143,13460,13462],0); -ELEMENTS[13028] = Fluid3D([13460,13857,13043,13827],0); -ELEMENTS[13029] = Fluid3D([13703,13199,12978,13702],0); -ELEMENTS[13030] = Fluid3D([13199,13488,12818,12614],0); -ELEMENTS[13031] = Fluid3D([13199,13488,12614,13462],0); -ELEMENTS[13032] = Fluid3D([12818,13199,12614,12207],0); -ELEMENTS[13033] = Fluid3D([13199,12614,12207,12753],0); -ELEMENTS[13034] = Fluid3D([13199,12614,12753,13462],0); -ELEMENTS[13035] = Fluid3D([13488,12818,12614,13043],0); -ELEMENTS[13036] = Fluid3D([12818,13199,12207,12978],0); -ELEMENTS[13037] = Fluid3D([12978,12818,13164,12264],0); -ELEMENTS[13038] = Fluid3D([13164,12978,12264,12799],0); -ELEMENTS[13039] = Fluid3D([12818,13164,12264,12528],0); -ELEMENTS[13040] = Fluid3D([12818,13164,12528,13503],0); -ELEMENTS[13041] = Fluid3D([13164,12264,12528,12506],0); -ELEMENTS[13042] = Fluid3D([13164,12264,12506,12799],0); -ELEMENTS[13043] = Fluid3D([12528,13164,12506,13300],0); -ELEMENTS[13044] = Fluid3D([12528,13164,13300,13503],0); -ELEMENTS[13045] = Fluid3D([12978,12818,12264,12207],0); -ELEMENTS[13046] = Fluid3D([13164,12506,13300,13296],0); -ELEMENTS[13047] = Fluid3D([13164,12506,13296,12799],0); -ELEMENTS[13048] = Fluid3D([13300,13164,13296,13839],0); -ELEMENTS[13049] = Fluid3D([13300,13164,13839,13503],0); -ELEMENTS[13050] = Fluid3D([13164,13296,13839,13907],0); -ELEMENTS[13051] = Fluid3D([13164,13296,13907,12799],0); -ELEMENTS[13052] = Fluid3D([12506,13300,13296,12931],0); -ELEMENTS[13053] = Fluid3D([12506,13300,12931,12369],0); -ELEMENTS[13054] = Fluid3D([13296,13839,13907,14252],0); -ELEMENTS[13055] = Fluid3D([13907,13296,14252,13550],0); -ELEMENTS[13056] = Fluid3D([13907,13296,13550,12799],0); -ELEMENTS[13057] = Fluid3D([12506,13300,12369,12528],0); -ELEMENTS[13058] = Fluid3D([13300,13296,12931,13814],0); -ELEMENTS[13059] = Fluid3D([13296,12931,13814,13564],0); -ELEMENTS[13060] = Fluid3D([13300,13296,13814,13839],0); -ELEMENTS[13061] = Fluid3D([12931,13814,13564,13539],0); -ELEMENTS[13062] = Fluid3D([12931,13814,13539,13282],0); -ELEMENTS[13063] = Fluid3D([12931,13814,13282,13300],0); -ELEMENTS[13064] = Fluid3D([13814,13564,13539,14309],0); -ELEMENTS[13065] = Fluid3D([13564,13539,14309,13871],0); -ELEMENTS[13066] = Fluid3D([13564,13539,13871,12883],0); -ELEMENTS[13067] = Fluid3D([13564,13539,12883,12931],0); -ELEMENTS[13068] = Fluid3D([13814,13564,14309,14252],0); -ELEMENTS[13069] = Fluid3D([13296,12931,13564,12670],0); -ELEMENTS[13070] = Fluid3D([13296,12931,12670,12506],0); -ELEMENTS[13071] = Fluid3D([13564,13296,12670,13550],0); -ELEMENTS[13072] = Fluid3D([12931,13564,12670,12883],0); -ELEMENTS[13073] = Fluid3D([13296,13839,14252,13814],0); -ELEMENTS[13074] = Fluid3D([13164,12978,12799,13907],0); -ELEMENTS[13075] = Fluid3D([12614,12207,12753,11724],0); -ELEMENTS[13076] = Fluid3D([12753,12614,11724,12376],0); -ELEMENTS[13077] = Fluid3D([12614,12207,11724,11839],0); -ELEMENTS[13078] = Fluid3D([11724,12753,12376,11810],0); -ELEMENTS[13079] = Fluid3D([11724,12614,11839,11904],0); -ELEMENTS[13080] = Fluid3D([11724,12614,11904,12376],0); -ELEMENTS[13081] = Fluid3D([11724,12753,11810,11689],0); -ELEMENTS[13082] = Fluid3D([11724,12753,11689,12207],0); -ELEMENTS[13083] = Fluid3D([11810,11724,11689,10910],0); -ELEMENTS[13084] = Fluid3D([11810,11724,10910,11293],0); -ELEMENTS[13085] = Fluid3D([11810,11724,11293,12376],0); -ELEMENTS[13086] = Fluid3D([11689,11810,10910,11256],0); -ELEMENTS[13087] = Fluid3D([11689,11810,11256,12203],0); -ELEMENTS[13088] = Fluid3D([11689,11810,12203,12753],0); -ELEMENTS[13089] = Fluid3D([11810,10910,11256,10403],0); -ELEMENTS[13090] = Fluid3D([12614,12207,11839,12818],0); -ELEMENTS[13091] = Fluid3D([11724,11689,10910,11068],0); -ELEMENTS[13092] = Fluid3D([11724,11689,11068,12207],0); -ELEMENTS[13093] = Fluid3D([11689,10910,11068,10719],0); -ELEMENTS[13094] = Fluid3D([11689,10910,10719,11256],0); -ELEMENTS[13095] = Fluid3D([10910,11724,11068,10780],0); -ELEMENTS[13096] = Fluid3D([10910,11724,10780,11293],0); -ELEMENTS[13097] = Fluid3D([11724,11068,10780,11839],0); -ELEMENTS[13098] = Fluid3D([11068,10910,10780,10082],0); -ELEMENTS[13099] = Fluid3D([10780,11068,10082,10470],0); -ELEMENTS[13100] = Fluid3D([10780,11068,10470,11839],0); -ELEMENTS[13101] = Fluid3D([11068,10910,10082,10719],0); -ELEMENTS[13102] = Fluid3D([10910,10780,10082,10112],0); -ELEMENTS[13103] = Fluid3D([10910,10780,10112,11293],0); -ELEMENTS[13104] = Fluid3D([10780,10082,10112,9776],0); -ELEMENTS[13105] = Fluid3D([10780,10082,9776,10470],0); -ELEMENTS[13106] = Fluid3D([10112,10780,9776,10366],0); -ELEMENTS[13107] = Fluid3D([10112,10780,10366,11293],0); -ELEMENTS[13108] = Fluid3D([10780,9776,10366,10498],0); -ELEMENTS[13109] = Fluid3D([10780,9776,10498,10470],0); -ELEMENTS[13110] = Fluid3D([9776,10366,10498,9649],0); -ELEMENTS[13111] = Fluid3D([9776,10366,9649,9368],0); -ELEMENTS[13112] = Fluid3D([10366,10498,9649,10569],0); -ELEMENTS[13113] = Fluid3D([10366,10498,10569,11315],0); -ELEMENTS[13114] = Fluid3D([10366,10498,11315,10780],0); -ELEMENTS[13115] = Fluid3D([9776,10366,9368,10112],0); -ELEMENTS[13116] = Fluid3D([10082,10910,10112,9968],0); -ELEMENTS[13117] = Fluid3D([10910,10112,9968,10403],0); -ELEMENTS[13118] = Fluid3D([10082,10910,9968,10719],0); -ELEMENTS[13119] = Fluid3D([10112,10082,9968,9239],0); -ELEMENTS[13120] = Fluid3D([9968,10112,9239,9266],0); -ELEMENTS[13121] = Fluid3D([10112,10082,9239,9776],0); -ELEMENTS[13122] = Fluid3D([10082,9968,9239,9415],0); -ELEMENTS[13123] = Fluid3D([10082,9968,9415,10719],0); -ELEMENTS[13124] = Fluid3D([9968,9239,9415,9020],0); -ELEMENTS[13125] = Fluid3D([9968,9239,9020,9266],0); -ELEMENTS[13126] = Fluid3D([9415,9968,9020,9701],0); -ELEMENTS[13127] = Fluid3D([9415,9968,9701,10719],0); -ELEMENTS[13128] = Fluid3D([9968,9020,9701,9770],0); -ELEMENTS[13129] = Fluid3D([9968,9020,9770,9266],0); -ELEMENTS[13130] = Fluid3D([9239,10082,9415,9208],0); -ELEMENTS[13131] = Fluid3D([10082,9415,9208,9917],0); -ELEMENTS[13132] = Fluid3D([9415,9239,9208,8517],0); -ELEMENTS[13133] = Fluid3D([9239,10082,9208,9776],0); -ELEMENTS[13134] = Fluid3D([9415,9239,8517,9020],0); -ELEMENTS[13135] = Fluid3D([10082,9415,9917,10719],0); -ELEMENTS[13136] = Fluid3D([12753,12614,12376,13462],0); -ELEMENTS[13137] = Fluid3D([12978,12264,12799,12177],0); -ELEMENTS[13138] = Fluid3D([12799,12978,12177,13058],0); -ELEMENTS[13139] = Fluid3D([12978,12264,12177,12207],0); -ELEMENTS[13140] = Fluid3D([12978,12177,13058,12629],0); -ELEMENTS[13141] = Fluid3D([12978,12177,12629,12207],0); -ELEMENTS[13142] = Fluid3D([13058,12978,12629,13702],0); -ELEMENTS[13143] = Fluid3D([12264,12799,12177,11835],0); -ELEMENTS[13144] = Fluid3D([12177,12264,11835,11365],0); -ELEMENTS[13145] = Fluid3D([12177,12264,11365,12207],0); -ELEMENTS[13146] = Fluid3D([12264,12799,11835,12506],0); -ELEMENTS[13147] = Fluid3D([12799,12177,11835,12313],0); -ELEMENTS[13148] = Fluid3D([12799,12177,12313,13058],0); -ELEMENTS[13149] = Fluid3D([12177,11835,12313,11390],0); -ELEMENTS[13150] = Fluid3D([12313,12177,11390,12093],0); -ELEMENTS[13151] = Fluid3D([11835,12799,12313,12520],0); -ELEMENTS[13152] = Fluid3D([12313,12177,12093,13058],0); -ELEMENTS[13153] = Fluid3D([11835,12799,12520,12506],0); -ELEMENTS[13154] = Fluid3D([12177,13058,12629,12093],0); -ELEMENTS[13155] = Fluid3D([12177,11835,11390,11365],0); -ELEMENTS[13156] = Fluid3D([12799,12978,13058,13907],0); -ELEMENTS[13157] = Fluid3D([12207,11724,11839,11068],0); -ELEMENTS[13158] = Fluid3D([12799,12313,12520,13187],0); -ELEMENTS[13159] = Fluid3D([12799,12313,13187,13058],0); -ELEMENTS[13160] = Fluid3D([12520,12799,13187,13550],0); -ELEMENTS[13161] = Fluid3D([12313,12520,13187,12685],0); -ELEMENTS[13162] = Fluid3D([12313,12520,12685,11647],0); -ELEMENTS[13163] = Fluid3D([12313,12520,11647,11835],0); -ELEMENTS[13164] = Fluid3D([12520,13187,12685,13147],0); -ELEMENTS[13165] = Fluid3D([12685,12520,13147,12248],0); -ELEMENTS[13166] = Fluid3D([12520,13187,13147,13550],0); -ELEMENTS[13167] = Fluid3D([13187,13147,13550,13694],0); -ELEMENTS[13168] = Fluid3D([13550,13187,13694,13996],0); -ELEMENTS[13169] = Fluid3D([13550,13187,13996,13907],0); -ELEMENTS[13170] = Fluid3D([13694,13550,13996,14490],0); -ELEMENTS[13171] = Fluid3D([13187,13694,13996,13576],0); -ELEMENTS[13172] = Fluid3D([13550,13996,14490,13907],0); -ELEMENTS[13173] = Fluid3D([13996,13187,13576,13058],0); -ELEMENTS[13174] = Fluid3D([13694,13550,14490,14020],0); -ELEMENTS[13175] = Fluid3D([13187,13694,13576,12685],0); -ELEMENTS[13176] = Fluid3D([13694,13550,14020,13147],0); -ELEMENTS[13177] = Fluid3D([13550,14490,14020,14252],0); -ELEMENTS[13178] = Fluid3D([13187,13147,13694,12685],0); -ELEMENTS[13179] = Fluid3D([14490,13694,14020,14646],0); -ELEMENTS[13180] = Fluid3D([13996,13694,14490,14899],0); -ELEMENTS[13181] = Fluid3D([13694,13996,13576,14110],0); -ELEMENTS[13182] = Fluid3D([13996,13576,14110,14081],0); -ELEMENTS[13183] = Fluid3D([13576,13694,14110,13813],0); -ELEMENTS[13184] = Fluid3D([13550,14020,13147,13564],0); -ELEMENTS[13185] = Fluid3D([13576,14110,14081,13922],0); -ELEMENTS[13186] = Fluid3D([13576,14110,13922,13813],0); -ELEMENTS[13187] = Fluid3D([14081,13576,13922,13343],0); -ELEMENTS[13188] = Fluid3D([14081,13576,13343,13058],0); -ELEMENTS[13189] = Fluid3D([13996,13576,14081,13058],0); -ELEMENTS[13190] = Fluid3D([13576,13694,13813,13010],0); -ELEMENTS[13191] = Fluid3D([13576,13694,13010,12685],0); -ELEMENTS[13192] = Fluid3D([13813,13576,13010,13091],0); -ELEMENTS[13193] = Fluid3D([13694,14110,13813,14146],0); -ELEMENTS[13194] = Fluid3D([12685,12520,12248,11647],0); -ELEMENTS[13195] = Fluid3D([13694,13996,14110,14899],0); -ELEMENTS[13196] = Fluid3D([14110,13996,14081,14899],0); -ELEMENTS[13197] = Fluid3D([14081,14110,14899,14690],0); -ELEMENTS[13198] = Fluid3D([14110,14899,14690,14399],0); -ELEMENTS[13199] = Fluid3D([14110,14899,14399,14646],0); -ELEMENTS[13200] = Fluid3D([14110,14899,14646,13694],0); -ELEMENTS[13201] = Fluid3D([14399,14110,14646,14146],0); -ELEMENTS[13202] = Fluid3D([14646,14110,13694,14146],0); -ELEMENTS[13203] = Fluid3D([13187,12313,12685,13576],0); -ELEMENTS[13204] = Fluid3D([12685,12313,11647,12050],0); -ELEMENTS[13205] = Fluid3D([12685,12313,12050,12694],0); -ELEMENTS[13206] = Fluid3D([12050,12685,12694,13010],0); -ELEMENTS[13207] = Fluid3D([12685,12694,13010,13576],0); -ELEMENTS[13208] = Fluid3D([12694,13010,13576,13091],0); -ELEMENTS[13209] = Fluid3D([13576,12694,13091,13343],0); -ELEMENTS[13210] = Fluid3D([12694,13010,13091,12050],0); -ELEMENTS[13211] = Fluid3D([13576,12694,13343,13058],0); -ELEMENTS[13212] = Fluid3D([11647,12685,12050,11829],0); -ELEMENTS[13213] = Fluid3D([12685,12050,11829,12467],0); -ELEMENTS[13214] = Fluid3D([12685,12050,12467,13010],0); -ELEMENTS[13215] = Fluid3D([12467,12685,13010,12605],0); -ELEMENTS[13216] = Fluid3D([12685,13010,12605,13694],0); -ELEMENTS[13217] = Fluid3D([13010,12467,12605,13182],0); -ELEMENTS[13218] = Fluid3D([13010,12467,13182,13091],0); -ELEMENTS[13219] = Fluid3D([13010,12467,13091,12050],0); -ELEMENTS[13220] = Fluid3D([12605,13010,13182,13694],0); -ELEMENTS[13221] = Fluid3D([12467,12685,12605,11829],0); -ELEMENTS[13222] = Fluid3D([12685,12605,11829,12248],0); -ELEMENTS[13223] = Fluid3D([12467,12605,13182,12240],0); -ELEMENTS[13224] = Fluid3D([13182,12467,12240,12715],0); -ELEMENTS[13225] = Fluid3D([13182,12467,12715,13091],0); -ELEMENTS[13226] = Fluid3D([12605,12467,11829,12240],0); -ELEMENTS[13227] = Fluid3D([12467,12240,12715,11680],0); -ELEMENTS[13228] = Fluid3D([12467,12240,11680,11829],0); -ELEMENTS[13229] = Fluid3D([12467,12715,13091,12236],0); -ELEMENTS[13230] = Fluid3D([13091,12467,12236,12050],0); -ELEMENTS[13231] = Fluid3D([12467,12715,12236,11680],0); -ELEMENTS[13232] = Fluid3D([12236,12467,11680,12050],0); -ELEMENTS[13233] = Fluid3D([12240,13182,12715,13638],0); -ELEMENTS[13234] = Fluid3D([12605,13182,12240,12903],0); -ELEMENTS[13235] = Fluid3D([13182,12240,12903,13638],0); -ELEMENTS[13236] = Fluid3D([12605,13182,12903,13533],0); -ELEMENTS[13237] = Fluid3D([13182,12903,13533,13890],0); -ELEMENTS[13238] = Fluid3D([12903,13533,13890,13342],0); -ELEMENTS[13239] = Fluid3D([13533,13890,13342,14386],0); -ELEMENTS[13240] = Fluid3D([13890,12903,13342,13650],0); -ELEMENTS[13241] = Fluid3D([12903,13533,13342,12605],0); -ELEMENTS[13242] = Fluid3D([12605,13182,13533,13694],0); -ELEMENTS[13243] = Fluid3D([12715,12236,11680,12074],0); -ELEMENTS[13244] = Fluid3D([12236,11680,12074,11318],0); -ELEMENTS[13245] = Fluid3D([12236,11680,11318,11410],0); -ELEMENTS[13246] = Fluid3D([12236,11680,11410,12050],0); -ELEMENTS[13247] = Fluid3D([11410,12236,12050,11708],0); -ELEMENTS[13248] = Fluid3D([12050,11410,11708,10983],0); -ELEMENTS[13249] = Fluid3D([12050,11410,10983,11829],0); -ELEMENTS[13250] = Fluid3D([12050,11410,11829,11680],0); -ELEMENTS[13251] = Fluid3D([11410,11708,10983,10785],0); -ELEMENTS[13252] = Fluid3D([11410,11708,10785,11318],0); -ELEMENTS[13253] = Fluid3D([10785,11410,11318,10618],0); -ELEMENTS[13254] = Fluid3D([11318,10785,10618,10324],0); -ELEMENTS[13255] = Fluid3D([11318,10785,10324,10986],0); -ELEMENTS[13256] = Fluid3D([11318,10785,10986,11708],0); -ELEMENTS[13257] = Fluid3D([10983,11410,10785,10618],0); -ELEMENTS[13258] = Fluid3D([10785,10618,10324,9819],0); -ELEMENTS[13259] = Fluid3D([10785,10324,10986,10049],0); -ELEMENTS[13260] = Fluid3D([10785,10618,9819,10983],0); -ELEMENTS[13261] = Fluid3D([10785,10324,10049,9819],0); -ELEMENTS[13262] = Fluid3D([11708,12050,10983,12093],0); -ELEMENTS[13263] = Fluid3D([10324,11318,10986,11051],0); -ELEMENTS[13264] = Fluid3D([11318,10986,11051,11890],0); -ELEMENTS[13265] = Fluid3D([10986,10785,10049,10920],0); -ELEMENTS[13266] = Fluid3D([10986,10785,10920,11708],0); -ELEMENTS[13267] = Fluid3D([10618,11318,10324,10814],0); -ELEMENTS[13268] = Fluid3D([11318,10986,11890,11708],0); -ELEMENTS[13269] = Fluid3D([10618,11318,10814,11680],0); -ELEMENTS[13270] = Fluid3D([11680,12074,11318,10814],0); -ELEMENTS[13271] = Fluid3D([10324,11318,11051,10814],0); -ELEMENTS[13272] = Fluid3D([10785,10049,10920,10179],0); -ELEMENTS[13273] = Fluid3D([11708,10983,10785,10920],0); -ELEMENTS[13274] = Fluid3D([10986,10324,11051,10363],0); -ELEMENTS[13275] = Fluid3D([12074,12236,11318,11890],0); -ELEMENTS[13276] = Fluid3D([11051,10986,10363,11197],0); -ELEMENTS[13277] = Fluid3D([10324,10618,10814,9833],0); -ELEMENTS[13278] = Fluid3D([10814,10324,9833,10018],0); -ELEMENTS[13279] = Fluid3D([10814,10324,10018,11051],0); -ELEMENTS[13280] = Fluid3D([10618,10814,9833,10031],0); -ELEMENTS[13281] = Fluid3D([11051,10986,11197,11890],0); -ELEMENTS[13282] = Fluid3D([10324,11051,10363,10018],0); -ELEMENTS[13283] = Fluid3D([11051,11318,11890,12074],0); -ELEMENTS[13284] = Fluid3D([11318,12236,11410,11708],0); -ELEMENTS[13285] = Fluid3D([10618,10324,9819,9833],0); -ELEMENTS[13286] = Fluid3D([10049,10920,10179,9865],0); -ELEMENTS[13287] = Fluid3D([10179,10049,9865,9165],0); -ELEMENTS[13288] = Fluid3D([10179,10049,9165,9819],0); -ELEMENTS[13289] = Fluid3D([11680,11318,11410,10618],0); -ELEMENTS[13290] = Fluid3D([10785,10049,10179,9819],0); -ELEMENTS[13291] = Fluid3D([10920,10785,10179,10983],0); -ELEMENTS[13292] = Fluid3D([10049,10986,10920,10524],0); -ELEMENTS[13293] = Fluid3D([10986,10920,10524,11519],0); -ELEMENTS[13294] = Fluid3D([10049,10986,10524,10363],0); -ELEMENTS[13295] = Fluid3D([10524,10986,11519,11197],0); -ELEMENTS[13296] = Fluid3D([10986,10920,11519,11708],0); -ELEMENTS[13297] = Fluid3D([10324,10986,10049,10363],0); -ELEMENTS[13298] = Fluid3D([12240,12715,11680,12107],0); -ELEMENTS[13299] = Fluid3D([11647,12685,11829,12248],0); -ELEMENTS[13300] = Fluid3D([12240,12715,12107,12919],0); -ELEMENTS[13301] = Fluid3D([12715,12107,12919,13395],0); -ELEMENTS[13302] = Fluid3D([12919,12715,13395,13638],0); -ELEMENTS[13303] = Fluid3D([13395,12919,13638,13115],0); -ELEMENTS[13304] = Fluid3D([12919,13638,13115,13378],0); -ELEMENTS[13305] = Fluid3D([13395,12919,13115,12107],0); -ELEMENTS[13306] = Fluid3D([13115,12919,13378,12445],0); -ELEMENTS[13307] = Fluid3D([13115,12919,12445,12107],0); -ELEMENTS[13308] = Fluid3D([12240,12715,12919,13638],0); -ELEMENTS[13309] = Fluid3D([12685,12313,12694,13576],0); -ELEMENTS[13310] = Fluid3D([12313,11647,12050,11390],0); -ELEMENTS[13311] = Fluid3D([12313,12050,12694,12093],0); -ELEMENTS[13312] = Fluid3D([13147,12685,12248,12605],0); -ELEMENTS[13313] = Fluid3D([12050,11647,11829,10983],0); -ELEMENTS[13314] = Fluid3D([11068,11689,10719,11405],0); -ELEMENTS[13315] = Fluid3D([11068,11689,11405,12207],0); -ELEMENTS[13316] = Fluid3D([11689,10719,11405,11668],0); -ELEMENTS[13317] = Fluid3D([10719,11068,11405,9917],0); -ELEMENTS[13318] = Fluid3D([10719,11405,11668,10737],0); -ELEMENTS[13319] = Fluid3D([11668,10719,10737,10545],0); -ELEMENTS[13320] = Fluid3D([10737,11668,10545,11132],0); -ELEMENTS[13321] = Fluid3D([10737,11668,11132,11699],0); -ELEMENTS[13322] = Fluid3D([10737,11668,11699,11405],0); -ELEMENTS[13323] = Fluid3D([10719,11405,10737,9917],0); -ELEMENTS[13324] = Fluid3D([11668,10719,10545,11256],0); -ELEMENTS[13325] = Fluid3D([11689,10719,11668,11256],0); -ELEMENTS[13326] = Fluid3D([11405,11689,11668,12629],0); -ELEMENTS[13327] = Fluid3D([11668,10545,11132,11391],0); -ELEMENTS[13328] = Fluid3D([11668,10545,11391,11256],0); -ELEMENTS[13329] = Fluid3D([11132,11668,11391,12110],0); -ELEMENTS[13330] = Fluid3D([11132,11668,12110,11699],0); -ELEMENTS[13331] = Fluid3D([10545,11132,11391,10563],0); -ELEMENTS[13332] = Fluid3D([10545,11132,10563,10090],0); -ELEMENTS[13333] = Fluid3D([11391,11132,12110,11613],0); -ELEMENTS[13334] = Fluid3D([11132,11391,10563,11613],0); -ELEMENTS[13335] = Fluid3D([11132,10563,10090,10681],0); -ELEMENTS[13336] = Fluid3D([10090,11132,10681,10920],0); -ELEMENTS[13337] = Fluid3D([11132,10563,10681,11613],0); -ELEMENTS[13338] = Fluid3D([10545,11132,10090,10737],0); -ELEMENTS[13339] = Fluid3D([10563,10090,10681,9760],0); -ELEMENTS[13340] = Fluid3D([10090,10681,9760,9865],0); -ELEMENTS[13341] = Fluid3D([10090,10681,9865,10920],0); -ELEMENTS[13342] = Fluid3D([9760,10090,9865,9200],0); -ELEMENTS[13343] = Fluid3D([10090,9865,9200,9684],0); -ELEMENTS[13344] = Fluid3D([10090,9865,9684,10737],0); -ELEMENTS[13345] = Fluid3D([9200,10090,9684,9518],0); -ELEMENTS[13346] = Fluid3D([9200,10090,9518,9550],0); -ELEMENTS[13347] = Fluid3D([9200,10090,9550,9760],0); -ELEMENTS[13348] = Fluid3D([10090,9550,9760,10563],0); -ELEMENTS[13349] = Fluid3D([9550,9760,10563,9849],0); -ELEMENTS[13350] = Fluid3D([9550,9760,9849,8964],0); -ELEMENTS[13351] = Fluid3D([9550,9760,8964,9200],0); -ELEMENTS[13352] = Fluid3D([10090,9684,9518,10737],0); -ELEMENTS[13353] = Fluid3D([9760,9849,8964,9444],0); -ELEMENTS[13354] = Fluid3D([9849,9550,8964,9132],0); -ELEMENTS[13355] = Fluid3D([8964,9760,9444,9084],0); -ELEMENTS[13356] = Fluid3D([8964,9760,9084,9200],0); -ELEMENTS[13357] = Fluid3D([10090,9518,9550,10545],0); -ELEMENTS[13358] = Fluid3D([9550,8964,9132,8722],0); -ELEMENTS[13359] = Fluid3D([9550,8964,8722,9200],0); -ELEMENTS[13360] = Fluid3D([9760,9849,9444,10525],0); -ELEMENTS[13361] = Fluid3D([9760,9849,10525,10563],0); -ELEMENTS[13362] = Fluid3D([9849,9550,9132,10069],0); -ELEMENTS[13363] = Fluid3D([9849,9550,10069,10563],0); -ELEMENTS[13364] = Fluid3D([9865,9200,9684,9165],0); -ELEMENTS[13365] = Fluid3D([9760,9444,9084,9906],0); -ELEMENTS[13366] = Fluid3D([9444,9760,10525,9906],0); -ELEMENTS[13367] = Fluid3D([9084,9760,9906,9865],0); -ELEMENTS[13368] = Fluid3D([9132,9550,8722,9701],0); -ELEMENTS[13369] = Fluid3D([9550,9132,10069,9701],0); -ELEMENTS[13370] = Fluid3D([9518,9200,9550,8722],0); -ELEMENTS[13371] = Fluid3D([8964,9132,8722,8252],0); -ELEMENTS[13372] = Fluid3D([9444,9084,9906,9267],0); -ELEMENTS[13373] = Fluid3D([9906,9444,9267,10288],0); -ELEMENTS[13374] = Fluid3D([9906,9444,10288,10525],0); -ELEMENTS[13375] = Fluid3D([9684,9200,9518,8912],0); -ELEMENTS[13376] = Fluid3D([9200,9518,8912,8722],0); -ELEMENTS[13377] = Fluid3D([9518,9684,8912,9509],0); -ELEMENTS[13378] = Fluid3D([9518,9684,9509,10737],0); -ELEMENTS[13379] = Fluid3D([8912,9518,9509,9415],0); -ELEMENTS[13380] = Fluid3D([9518,9509,9415,10719],0); -ELEMENTS[13381] = Fluid3D([8722,8964,8252,8094],0); -ELEMENTS[13382] = Fluid3D([8722,8964,8094,9200],0); -ELEMENTS[13383] = Fluid3D([8964,8252,8094,8231],0); -ELEMENTS[13384] = Fluid3D([8964,8252,8231,8908],0); -ELEMENTS[13385] = Fluid3D([8964,8252,8908,9132],0); -ELEMENTS[13386] = Fluid3D([8252,8722,8094,7604],0); -ELEMENTS[13387] = Fluid3D([8252,8722,7604,8270],0); -ELEMENTS[13388] = Fluid3D([9132,9849,10069,10325],0); -ELEMENTS[13389] = Fluid3D([8964,9849,9132,8908],0); -ELEMENTS[13390] = Fluid3D([8094,8964,8231,9084],0); -ELEMENTS[13391] = Fluid3D([9444,8964,9084,8231],0); -ELEMENTS[13392] = Fluid3D([10090,9550,10563,10545],0); -ELEMENTS[13393] = Fluid3D([8722,8094,7604,8152],0); -ELEMENTS[13394] = Fluid3D([8722,8094,8152,9200],0); -ELEMENTS[13395] = Fluid3D([9849,9444,10525,10181],0); -ELEMENTS[13396] = Fluid3D([10525,9849,10181,10847],0); -ELEMENTS[13397] = Fluid3D([9849,9444,10181,8908],0); -ELEMENTS[13398] = Fluid3D([9849,10181,10847,10057],0); -ELEMENTS[13399] = Fluid3D([9849,10181,10057,8908],0); -ELEMENTS[13400] = Fluid3D([10847,9849,10057,10325],0); -ELEMENTS[13401] = Fluid3D([10525,9849,10847,10563],0); -ELEMENTS[13402] = Fluid3D([10181,10525,10847,10951],0); -ELEMENTS[13403] = Fluid3D([10525,10847,10951,11613],0); -ELEMENTS[13404] = Fluid3D([10181,10525,10951,10288],0); -ELEMENTS[13405] = Fluid3D([9849,8964,9444,8908],0); -ELEMENTS[13406] = Fluid3D([9084,9906,9267,9276],0); -ELEMENTS[13407] = Fluid3D([10525,9760,10563,10681],0); -ELEMENTS[13408] = Fluid3D([9684,9865,9165,10179],0); -ELEMENTS[13409] = Fluid3D([9684,9865,10179,10737],0); -ELEMENTS[13410] = Fluid3D([9165,9684,10179,9393],0); -ELEMENTS[13411] = Fluid3D([9684,10179,9393,10270],0); -ELEMENTS[13412] = Fluid3D([9684,10179,10270,10737],0); -ELEMENTS[13413] = Fluid3D([10179,9393,10270,10983],0); -ELEMENTS[13414] = Fluid3D([9393,9684,10270,9509],0); -ELEMENTS[13415] = Fluid3D([10179,9165,9393,9819],0); -ELEMENTS[13416] = Fluid3D([9132,8722,8252,8270],0); -ELEMENTS[13417] = Fluid3D([8094,7604,8152,7287],0); -ELEMENTS[13418] = Fluid3D([8152,8094,7287,7899],0); -ELEMENTS[13419] = Fluid3D([8094,7604,7287,7260],0); -ELEMENTS[13420] = Fluid3D([8094,7604,7260,8252],0); -ELEMENTS[13421] = Fluid3D([7287,8152,7899,7362],0); -ELEMENTS[13422] = Fluid3D([7287,8152,7362,7231],0); -ELEMENTS[13423] = Fluid3D([7287,8152,7231,7604],0); -ELEMENTS[13424] = Fluid3D([7899,7287,7362,7037],0); -ELEMENTS[13425] = Fluid3D([7362,7899,7037,7502],0); -ELEMENTS[13426] = Fluid3D([7362,7899,7502,8153],0); -ELEMENTS[13427] = Fluid3D([7362,7899,8153,8152],0); -ELEMENTS[13428] = Fluid3D([7899,7287,7037,7600],0); -ELEMENTS[13429] = Fluid3D([7899,7287,7600,8094],0); -ELEMENTS[13430] = Fluid3D([7287,7037,7600,6668],0); -ELEMENTS[13431] = Fluid3D([7600,7287,6668,7260],0); -ELEMENTS[13432] = Fluid3D([7287,7037,6668,6522],0); -ELEMENTS[13433] = Fluid3D([7037,6668,6522,6102],0); -ELEMENTS[13434] = Fluid3D([7037,6668,6102,6688],0); -ELEMENTS[13435] = Fluid3D([7037,6668,6688,7600],0); -ELEMENTS[13436] = Fluid3D([7287,7037,6522,7362],0); -ELEMENTS[13437] = Fluid3D([8152,8094,7899,9200],0); -ELEMENTS[13438] = Fluid3D([7287,8094,7260,7600],0); -ELEMENTS[13439] = Fluid3D([11668,11391,12110,12203],0); -ELEMENTS[13440] = Fluid3D([11391,10545,10563,10069],0); -ELEMENTS[13441] = Fluid3D([11835,12313,11390,11647],0); -ELEMENTS[13442] = Fluid3D([10719,10737,10545,9518],0); -ELEMENTS[13443] = Fluid3D([14302,13488,13857,13503],0); -ELEMENTS[13444] = Fluid3D([12207,13199,12753,12629],0); -ELEMENTS[13445] = Fluid3D([14252,13907,13550,14490],0); -ELEMENTS[13446] = Fluid3D([12753,12376,11810,12784],0); -ELEMENTS[13447] = Fluid3D([12753,12376,12784,13462],0); -ELEMENTS[13448] = Fluid3D([11810,12753,12784,12203],0); -ELEMENTS[13449] = Fluid3D([12376,11810,12784,12097],0); -ELEMENTS[13450] = Fluid3D([12784,12376,12097,12993],0); -ELEMENTS[13451] = Fluid3D([12376,11810,12097,11293],0); -ELEMENTS[13452] = Fluid3D([12376,12097,12993,12238],0); -ELEMENTS[13453] = Fluid3D([12376,12097,12238,11293],0); -ELEMENTS[13454] = Fluid3D([12097,12993,12238,12377],0); -ELEMENTS[13455] = Fluid3D([12238,12097,12377,11451],0); -ELEMENTS[13456] = Fluid3D([12377,12238,11451,11954],0); -ELEMENTS[13457] = Fluid3D([12993,12238,12377,13369],0); -ELEMENTS[13458] = Fluid3D([12238,12097,11451,11293],0); -ELEMENTS[13459] = Fluid3D([12097,12377,11451,11594],0); -ELEMENTS[13460] = Fluid3D([12377,11451,11594,11954],0); -ELEMENTS[13461] = Fluid3D([12784,12376,12993,13462],0); -ELEMENTS[13462] = Fluid3D([12097,12784,12993,12996],0); -ELEMENTS[13463] = Fluid3D([12784,12993,12996,13844],0); -ELEMENTS[13464] = Fluid3D([12097,12784,12996,12367],0); -ELEMENTS[13465] = Fluid3D([12993,12097,12996,12377],0); -ELEMENTS[13466] = Fluid3D([11810,12784,12097,11888],0); -ELEMENTS[13467] = Fluid3D([12784,12097,11888,12367],0); -ELEMENTS[13468] = Fluid3D([11810,12784,11888,12203],0); -ELEMENTS[13469] = Fluid3D([12097,11810,11888,11211],0); -ELEMENTS[13470] = Fluid3D([12097,11810,11211,11293],0); -ELEMENTS[13471] = Fluid3D([11810,11888,11211,11256],0); -ELEMENTS[13472] = Fluid3D([11888,12097,11211,11300],0); -ELEMENTS[13473] = Fluid3D([12993,12376,12238,12988],0); -ELEMENTS[13474] = Fluid3D([12993,12376,12988,13462],0); -ELEMENTS[13475] = Fluid3D([12376,12238,12988,11904],0); -ELEMENTS[13476] = Fluid3D([12238,12993,12988,13369],0); -ELEMENTS[13477] = Fluid3D([9415,9208,9917,9509],0); -ELEMENTS[13478] = Fluid3D([9917,9415,9509,10719],0); -ELEMENTS[13479] = Fluid3D([9208,9917,9509,9285],0); -ELEMENTS[13480] = Fluid3D([9917,9509,9285,10270],0); -ELEMENTS[13481] = Fluid3D([9917,9509,10270,10737],0); -ELEMENTS[13482] = Fluid3D([9208,9917,9285,10470],0); -ELEMENTS[13483] = Fluid3D([13462,14031,14143,14305],0); -ELEMENTS[13484] = Fluid3D([14143,14031,14302,14886],0); -ELEMENTS[13485] = Fluid3D([14031,14302,14886,14301],0); -ELEMENTS[13486] = Fluid3D([14302,14886,14301,14458],0); -ELEMENTS[13487] = Fluid3D([14302,14886,14458,14611],0); -ELEMENTS[13488] = Fluid3D([14302,14886,14611,14143],0); -ELEMENTS[13489] = Fluid3D([14301,14302,14458,13503],0); -ELEMENTS[13490] = Fluid3D([14611,14302,14143,13857],0); -ELEMENTS[13491] = Fluid3D([14611,14302,13857,14340],0); -ELEMENTS[13492] = Fluid3D([13857,14611,14340,14324],0); -ELEMENTS[13493] = Fluid3D([13857,14611,14324,14557],0); -ELEMENTS[13494] = Fluid3D([14611,14302,14340,14458],0); -ELEMENTS[13495] = Fluid3D([14143,14611,13857,14557],0); -ELEMENTS[13496] = Fluid3D([14611,14340,14324,14806],0); -ELEMENTS[13497] = Fluid3D([14302,14340,14458,13503],0); -ELEMENTS[13498] = Fluid3D([14340,13857,14324,13744],0); -ELEMENTS[13499] = Fluid3D([13857,14324,13744,14444],0); -ELEMENTS[13500] = Fluid3D([14340,13857,13744,13503],0); -ELEMENTS[13501] = Fluid3D([14302,13857,14340,13503],0); -ELEMENTS[13502] = Fluid3D([14886,14301,14458,15180],0); -ELEMENTS[13503] = Fluid3D([14458,14886,15180,15666],0); -ELEMENTS[13504] = Fluid3D([14324,14340,13744,14806],0); -ELEMENTS[13505] = Fluid3D([14031,14302,14301,13703],0); -ELEMENTS[13506] = Fluid3D([14302,14301,13703,13503],0); -ELEMENTS[13507] = Fluid3D([14301,14031,13703,13702],0); -ELEMENTS[13508] = Fluid3D([14301,14458,15180,14578],0); -ELEMENTS[13509] = Fluid3D([14458,15180,14578,15334],0); -ELEMENTS[13510] = Fluid3D([14458,15180,15334,15666],0); -ELEMENTS[13511] = Fluid3D([15180,14578,15334,15377],0); -ELEMENTS[13512] = Fluid3D([15334,15180,15377,15967],0); -ELEMENTS[13513] = Fluid3D([14578,15334,15377,15111],0); -ELEMENTS[13514] = Fluid3D([14578,15334,15111,14632],0); -ELEMENTS[13515] = Fluid3D([15111,14578,14632,14252],0); -ELEMENTS[13516] = Fluid3D([14578,15334,14632,14458],0); -ELEMENTS[13517] = Fluid3D([14886,14301,15180,14998],0); -ELEMENTS[13518] = Fluid3D([15180,14886,14998,15467],0); -ELEMENTS[13519] = Fluid3D([14301,15180,14998,14780],0); -ELEMENTS[13520] = Fluid3D([15180,14998,14780,15365],0); -ELEMENTS[13521] = Fluid3D([15180,14998,15365,15725],0); -ELEMENTS[13522] = Fluid3D([15180,14998,15725,15467],0); -ELEMENTS[13523] = Fluid3D([14998,14780,15365,14929],0); -ELEMENTS[13524] = Fluid3D([15365,14998,14929,15191],0); -ELEMENTS[13525] = Fluid3D([14998,14929,15191,14440],0); -ELEMENTS[13526] = Fluid3D([15191,14998,14440,14971],0); -ELEMENTS[13527] = Fluid3D([15191,14998,14971,15467],0); -ELEMENTS[13528] = Fluid3D([15365,14998,15191,15725],0); -ELEMENTS[13529] = Fluid3D([14998,15191,15725,15467],0); -ELEMENTS[13530] = Fluid3D([14998,14780,14929,13702],0); -ELEMENTS[13531] = Fluid3D([14301,15180,14780,14578],0); -ELEMENTS[13532] = Fluid3D([14780,15365,14929,15356],0); -ELEMENTS[13533] = Fluid3D([15191,15725,15467,15798],0); -ELEMENTS[13534] = Fluid3D([15725,15467,15798,16014],0); -ELEMENTS[13535] = Fluid3D([15377,14578,15111,14932],0); -ELEMENTS[13536] = Fluid3D([15111,15377,14932,15544],0); -ELEMENTS[13537] = Fluid3D([15377,14932,15544,15356],0); -ELEMENTS[13538] = Fluid3D([15111,15377,15544,15967],0); -ELEMENTS[13539] = Fluid3D([15377,15544,15967,15773],0); -ELEMENTS[13540] = Fluid3D([15377,15544,15773,15356],0); -ELEMENTS[13541] = Fluid3D([15377,14578,14932,14780],0); -ELEMENTS[13542] = Fluid3D([14578,15111,14932,14252],0); -ELEMENTS[13543] = Fluid3D([14932,14578,14252,13907],0); -ELEMENTS[13544] = Fluid3D([14998,14301,14780,13702],0); -ELEMENTS[13545] = Fluid3D([14301,14458,14578,13839],0); -ELEMENTS[13546] = Fluid3D([15180,14578,15377,14780],0); -ELEMENTS[13547] = Fluid3D([15334,15377,15111,15967],0); -ELEMENTS[13548] = Fluid3D([14780,15180,15365,15377],0); -ELEMENTS[13549] = Fluid3D([15365,15180,15725,16165],0); -ELEMENTS[13550] = Fluid3D([12264,12528,12506,11537],0); -ELEMENTS[13551] = Fluid3D([12506,12264,11537,11835],0); -ELEMENTS[13552] = Fluid3D([12264,12528,11537,11839],0); -ELEMENTS[13553] = Fluid3D([12528,12506,11537,12369],0); -ELEMENTS[13554] = Fluid3D([12931,12506,12369,11969],0); -ELEMENTS[13555] = Fluid3D([12931,12506,11969,12670],0); -ELEMENTS[13556] = Fluid3D([12506,12369,11969,11537],0); -ELEMENTS[13557] = Fluid3D([12369,12931,11969,12423],0); -ELEMENTS[13558] = Fluid3D([12369,12931,12423,13282],0); -ELEMENTS[13559] = Fluid3D([11969,12369,12423,11506],0); -ELEMENTS[13560] = Fluid3D([11969,12369,11506,11537],0); -ELEMENTS[13561] = Fluid3D([12369,12423,11506,12188],0); -ELEMENTS[13562] = Fluid3D([12423,11506,12188,11663],0); -ELEMENTS[13563] = Fluid3D([12369,12423,12188,13282],0); -ELEMENTS[13564] = Fluid3D([12188,12423,11663,12627],0); -ELEMENTS[13565] = Fluid3D([12423,11663,12627,12475],0); -ELEMENTS[13566] = Fluid3D([12423,11663,12475,11540],0); -ELEMENTS[13567] = Fluid3D([12423,11663,11540,11506],0); -ELEMENTS[13568] = Fluid3D([11506,12369,12188,11701],0); -ELEMENTS[13569] = Fluid3D([12188,11506,11701,11209],0); -ELEMENTS[13570] = Fluid3D([11506,12369,11701,11537],0); -ELEMENTS[13571] = Fluid3D([12188,11506,11209,11663],0); -ELEMENTS[13572] = Fluid3D([11663,12475,11540,11283],0); -ELEMENTS[13573] = Fluid3D([11540,11663,11283,10707],0); -ELEMENTS[13574] = Fluid3D([11663,12475,11283,11942],0); -ELEMENTS[13575] = Fluid3D([11283,11540,10707,10690],0); -ELEMENTS[13576] = Fluid3D([11663,12475,11942,12627],0); -ELEMENTS[13577] = Fluid3D([11283,11540,10690,11632],0); -ELEMENTS[13578] = Fluid3D([11283,11540,11632,12475],0); -ELEMENTS[13579] = Fluid3D([11540,10690,11632,11314],0); -ELEMENTS[13580] = Fluid3D([11632,11540,11314,12164],0); -ELEMENTS[13581] = Fluid3D([11632,11540,12164,12475],0); -ELEMENTS[13582] = Fluid3D([11540,10690,11314,10557],0); -ELEMENTS[13583] = Fluid3D([11540,10690,10557,10707],0); -ELEMENTS[13584] = Fluid3D([10690,11314,10557,10266],0); -ELEMENTS[13585] = Fluid3D([11314,10557,10266,10873],0); -ELEMENTS[13586] = Fluid3D([11314,10557,10873,11969],0); -ELEMENTS[13587] = Fluid3D([10690,11314,10266,10803],0); -ELEMENTS[13588] = Fluid3D([11314,10266,10803,10918],0); -ELEMENTS[13589] = Fluid3D([11314,10266,10918,10873],0); -ELEMENTS[13590] = Fluid3D([10690,11314,10803,11632],0); -ELEMENTS[13591] = Fluid3D([11540,11663,10707,11506],0); -ELEMENTS[13592] = Fluid3D([12188,12423,12627,13282],0); -ELEMENTS[13593] = Fluid3D([12369,12188,11701,12667],0); -ELEMENTS[13594] = Fluid3D([12188,11701,12667,12021],0); -ELEMENTS[13595] = Fluid3D([11701,12369,12667,12528],0); -ELEMENTS[13596] = Fluid3D([12369,12188,12667,13282],0); -ELEMENTS[13597] = Fluid3D([12667,12188,12021,12869],0); -ELEMENTS[13598] = Fluid3D([12667,12188,12869,13282],0); -ELEMENTS[13599] = Fluid3D([12021,12667,12869,12848],0); -ELEMENTS[13600] = Fluid3D([12667,12869,12848,13534],0); -ELEMENTS[13601] = Fluid3D([12667,12869,13534,13282],0); -ELEMENTS[13602] = Fluid3D([12021,12667,12848,12155],0); -ELEMENTS[13603] = Fluid3D([12667,12848,12155,13079],0); -ELEMENTS[13604] = Fluid3D([12667,12848,13079,13534],0); -ELEMENTS[13605] = Fluid3D([12021,12667,12155,11701],0); -ELEMENTS[13606] = Fluid3D([12188,11701,12021,11209],0); -ELEMENTS[13607] = Fluid3D([12188,12021,12869,12063],0); -ELEMENTS[13608] = Fluid3D([12021,12869,12063,12462],0); -ELEMENTS[13609] = Fluid3D([12869,12063,12462,12913],0); -ELEMENTS[13610] = Fluid3D([12869,12063,12913,12627],0); -ELEMENTS[13611] = Fluid3D([12188,12021,12063,11209],0); -ELEMENTS[13612] = Fluid3D([12869,12188,12063,12627],0); -ELEMENTS[13613] = Fluid3D([12021,12869,12462,12848],0); -ELEMENTS[13614] = Fluid3D([10707,11283,10690,10306],0); -ELEMENTS[13615] = Fluid3D([10707,11283,10306,10815],0); -ELEMENTS[13616] = Fluid3D([11283,10306,10815,10689],0); -ELEMENTS[13617] = Fluid3D([11283,10306,10689,10770],0); -ELEMENTS[13618] = Fluid3D([11283,10306,10770,10690],0); -ELEMENTS[13619] = Fluid3D([10690,10707,10306,9806],0); -ELEMENTS[13620] = Fluid3D([10306,10690,9806,9943],0); -ELEMENTS[13621] = Fluid3D([10306,10690,9943,10770],0); -ELEMENTS[13622] = Fluid3D([10690,10707,9806,10557],0); -ELEMENTS[13623] = Fluid3D([10707,11283,10815,11663],0); -ELEMENTS[13624] = Fluid3D([10707,10306,9806,9823],0); -ELEMENTS[13625] = Fluid3D([10306,9806,9823,9226],0); -ELEMENTS[13626] = Fluid3D([9823,10306,9226,9725],0); -ELEMENTS[13627] = Fluid3D([10707,10306,9823,10815],0); -ELEMENTS[13628] = Fluid3D([9823,10306,9725,10815],0); -ELEMENTS[13629] = Fluid3D([10306,9806,9226,9943],0); -ELEMENTS[13630] = Fluid3D([9806,10707,9823,9995],0); -ELEMENTS[13631] = Fluid3D([10707,9823,9995,10549],0); -ELEMENTS[13632] = Fluid3D([9995,10707,10549,11506],0); -ELEMENTS[13633] = Fluid3D([9806,10707,9995,10557],0); -ELEMENTS[13634] = Fluid3D([10707,9823,10549,10815],0); -ELEMENTS[13635] = Fluid3D([9823,9806,9995,9079],0); -ELEMENTS[13636] = Fluid3D([9823,9806,9079,9226],0); -ELEMENTS[13637] = Fluid3D([9806,9995,9079,9420],0); -ELEMENTS[13638] = Fluid3D([9995,9823,9079,9443],0); -ELEMENTS[13639] = Fluid3D([9823,9079,9443,8977],0); -ELEMENTS[13640] = Fluid3D([9995,9823,9443,10549],0); -ELEMENTS[13641] = Fluid3D([9079,9995,9443,9191],0); -ELEMENTS[13642] = Fluid3D([9443,9079,9191,8505],0); -ELEMENTS[13643] = Fluid3D([9443,9079,8505,8977],0); -ELEMENTS[13644] = Fluid3D([9079,9995,9191,9420],0); -ELEMENTS[13645] = Fluid3D([9823,9079,8977,9226],0); -ELEMENTS[13646] = Fluid3D([12869,12848,13534,13509],0); -ELEMENTS[13647] = Fluid3D([12869,12848,13509,12462],0); -ELEMENTS[13648] = Fluid3D([12848,13534,13509,13705],0); -ELEMENTS[13649] = Fluid3D([12848,13534,13705,13079],0); -ELEMENTS[13650] = Fluid3D([13509,12848,13705,13190],0); -ELEMENTS[13651] = Fluid3D([12848,13705,13190,12803],0); -ELEMENTS[13652] = Fluid3D([13509,12848,13190,12462],0); -ELEMENTS[13653] = Fluid3D([13534,13509,13705,14214],0); -ELEMENTS[13654] = Fluid3D([13509,13705,14214,14361],0); -ELEMENTS[13655] = Fluid3D([13705,13534,14214,14233],0); -ELEMENTS[13656] = Fluid3D([13534,14214,14233,14350],0); -ELEMENTS[13657] = Fluid3D([13534,14214,14350,13990],0); -ELEMENTS[13658] = Fluid3D([13534,14214,13990,13509],0); -ELEMENTS[13659] = Fluid3D([13705,13534,14233,13079],0); -ELEMENTS[13660] = Fluid3D([13534,12869,13509,13990],0); -ELEMENTS[13661] = Fluid3D([14214,13705,14233,14806],0); -ELEMENTS[13662] = Fluid3D([12462,12869,12913,13509],0); -ELEMENTS[13663] = Fluid3D([10306,10815,10689,9725],0); -ELEMENTS[13664] = Fluid3D([11506,11701,11209,10726],0); -ELEMENTS[13665] = Fluid3D([11506,11701,10726,11537],0); -ELEMENTS[13666] = Fluid3D([11209,11506,10726,10549],0); -ELEMENTS[13667] = Fluid3D([10726,11209,10549,10550],0); -ELEMENTS[13668] = Fluid3D([11209,10549,10550,10864],0); -ELEMENTS[13669] = Fluid3D([11209,10549,10864,10815],0); -ELEMENTS[13670] = Fluid3D([10550,11209,10864,12021],0); -ELEMENTS[13671] = Fluid3D([10549,10550,10864,9846],0); -ELEMENTS[13672] = Fluid3D([10864,10549,9846,10267],0); -ELEMENTS[13673] = Fluid3D([10864,10549,10267,10815],0); -ELEMENTS[13674] = Fluid3D([10549,10550,9846,9443],0); -ELEMENTS[13675] = Fluid3D([9846,10549,9443,9823],0); -ELEMENTS[13676] = Fluid3D([10549,10267,10815,9823],0); -ELEMENTS[13677] = Fluid3D([10267,10815,9823,9725],0); -ELEMENTS[13678] = Fluid3D([10549,10267,9823,9846],0); -ELEMENTS[13679] = Fluid3D([9823,10267,9725,8977],0); -ELEMENTS[13680] = Fluid3D([10726,11209,10550,11701],0); -ELEMENTS[13681] = Fluid3D([9846,10864,10267,10128],0); -ELEMENTS[13682] = Fluid3D([10864,10267,10128,11004],0); -ELEMENTS[13683] = Fluid3D([10864,10267,11004,10815],0); -ELEMENTS[13684] = Fluid3D([11209,11506,10549,10815],0); -ELEMENTS[13685] = Fluid3D([9846,10864,10128,10295],0); -ELEMENTS[13686] = Fluid3D([9846,10864,10295,10550],0); -ELEMENTS[13687] = Fluid3D([10864,10128,10295,11029],0); -ELEMENTS[13688] = Fluid3D([10864,10128,11029,11004],0); -ELEMENTS[13689] = Fluid3D([10267,10128,11004,10080],0); -ELEMENTS[13690] = Fluid3D([11004,10267,10080,10815],0); -ELEMENTS[13691] = Fluid3D([10267,10128,10080,9389],0); -ELEMENTS[13692] = Fluid3D([10267,10128,9389,9846],0); -ELEMENTS[13693] = Fluid3D([10295,10864,11029,11322],0); -ELEMENTS[13694] = Fluid3D([10295,10864,11322,10550],0); -ELEMENTS[13695] = Fluid3D([10864,11029,11322,12063],0); -ELEMENTS[13696] = Fluid3D([10080,10267,9389,9725],0); -ELEMENTS[13697] = Fluid3D([10128,9846,10295,9348],0); -ELEMENTS[13698] = Fluid3D([9846,10295,9348,9567],0); -ELEMENTS[13699] = Fluid3D([10128,11004,10080,10772],0); -ELEMENTS[13700] = Fluid3D([10128,11004,10772,11029],0); -ELEMENTS[13701] = Fluid3D([10267,10815,9725,10080],0); -ELEMENTS[13702] = Fluid3D([9846,10295,9567,10550],0); -ELEMENTS[13703] = Fluid3D([10128,9846,9348,9389],0); -ELEMENTS[13704] = Fluid3D([10128,10295,11029,10115],0); -ELEMENTS[13705] = Fluid3D([11029,10128,10115,10772],0); -ELEMENTS[13706] = Fluid3D([10128,10295,10115,9348],0); -ELEMENTS[13707] = Fluid3D([10295,11029,10115,10852],0); -ELEMENTS[13708] = Fluid3D([11029,10115,10852,10982],0); -ELEMENTS[13709] = Fluid3D([10295,11029,10852,11322],0); -ELEMENTS[13710] = Fluid3D([10852,11029,10982,11876],0); -ELEMENTS[13711] = Fluid3D([10115,10295,10852,9825],0); -ELEMENTS[13712] = Fluid3D([10982,10852,11876,11488],0); -ELEMENTS[13713] = Fluid3D([10982,10852,11488,10400],0); -ELEMENTS[13714] = Fluid3D([10982,10852,10400,10115],0); -ELEMENTS[13715] = Fluid3D([10115,10295,9825,9348],0); -ELEMENTS[13716] = Fluid3D([11029,10115,10982,10772],0); -ELEMENTS[13717] = Fluid3D([10852,11029,11876,11322],0); -ELEMENTS[13718] = Fluid3D([10128,10080,9389,9442],0); -ELEMENTS[13719] = Fluid3D([9389,10128,9442,9348],0); -ELEMENTS[13720] = Fluid3D([10128,10080,9442,10772],0); -ELEMENTS[13721] = Fluid3D([10080,9389,9442,9141],0); -ELEMENTS[13722] = Fluid3D([9389,9442,9141,8580],0); -ELEMENTS[13723] = Fluid3D([10080,9389,9141,9725],0); -ELEMENTS[13724] = Fluid3D([9141,9389,8580,8587],0); -ELEMENTS[13725] = Fluid3D([9389,8580,8587,8977],0); -ELEMENTS[13726] = Fluid3D([8587,9389,8977,9725],0); -ELEMENTS[13727] = Fluid3D([9442,10080,9141,9782],0); -ELEMENTS[13728] = Fluid3D([9442,10080,9782,10772],0); -ELEMENTS[13729] = Fluid3D([10080,9141,9782,9890],0); -ELEMENTS[13730] = Fluid3D([9141,9782,9890,9121],0); -ELEMENTS[13731] = Fluid3D([9141,9782,9121,8693],0); -ELEMENTS[13732] = Fluid3D([9141,9782,8693,9442],0); -ELEMENTS[13733] = Fluid3D([10080,9141,9890,9725],0); -ELEMENTS[13734] = Fluid3D([9389,9442,8580,9348],0); -ELEMENTS[13735] = Fluid3D([9141,9389,8587,9725],0); -ELEMENTS[13736] = Fluid3D([9442,9141,8580,8693],0); -ELEMENTS[13737] = Fluid3D([10295,10852,9825,10696],0); -ELEMENTS[13738] = Fluid3D([10295,10852,10696,11322],0); -ELEMENTS[13739] = Fluid3D([10852,9825,10696,10504],0); -ELEMENTS[13740] = Fluid3D([10852,9825,10504,10400],0); -ELEMENTS[13741] = Fluid3D([10696,10852,10504,11220],0); -ELEMENTS[13742] = Fluid3D([10696,10852,11220,11322],0); -ELEMENTS[13743] = Fluid3D([10852,10504,11220,11488],0); -ELEMENTS[13744] = Fluid3D([9825,10295,10696,9567],0); -ELEMENTS[13745] = Fluid3D([9825,10696,10504,9755],0); -ELEMENTS[13746] = Fluid3D([10504,9825,9755,9660],0); -ELEMENTS[13747] = Fluid3D([9825,10696,9755,9567],0); -ELEMENTS[13748] = Fluid3D([9755,10504,9660,10017],0); -ELEMENTS[13749] = Fluid3D([10504,9660,10017,10538],0); -ELEMENTS[13750] = Fluid3D([9755,10504,10017,10658],0); -ELEMENTS[13751] = Fluid3D([9755,10504,10658,10696],0); -ELEMENTS[13752] = Fluid3D([10504,10017,10658,11109],0); -ELEMENTS[13753] = Fluid3D([10504,10017,11109,10538],0); -ELEMENTS[13754] = Fluid3D([10658,10504,11109,11220],0); -ELEMENTS[13755] = Fluid3D([10504,9825,9660,10400],0); -ELEMENTS[13756] = Fluid3D([10017,10658,11109,10670],0); -ELEMENTS[13757] = Fluid3D([10658,11109,10670,11972],0); -ELEMENTS[13758] = Fluid3D([10017,10658,10670,9845],0); -ELEMENTS[13759] = Fluid3D([10670,10017,9845,9505],0); -ELEMENTS[13760] = Fluid3D([10017,10658,9845,9755],0); -ELEMENTS[13761] = Fluid3D([11109,10017,10670,10235],0); -ELEMENTS[13762] = Fluid3D([10658,10670,9845,10760],0); -ELEMENTS[13763] = Fluid3D([10670,9845,10760,10540],0); -ELEMENTS[13764] = Fluid3D([10760,10670,10540,11807],0); -ELEMENTS[13765] = Fluid3D([10658,10670,10760,11972],0); -ELEMENTS[13766] = Fluid3D([9845,10658,10760,10178],0); -ELEMENTS[13767] = Fluid3D([9845,10658,10178,9755],0); -ELEMENTS[13768] = Fluid3D([10658,10760,10178,11225],0); -ELEMENTS[13769] = Fluid3D([10178,10658,11225,10696],0); -ELEMENTS[13770] = Fluid3D([10658,10760,11225,11972],0); -ELEMENTS[13771] = Fluid3D([10760,9845,10178,9887],0); -ELEMENTS[13772] = Fluid3D([10760,9845,9887,10540],0); -ELEMENTS[13773] = Fluid3D([9845,10178,9887,9204],0); -ELEMENTS[13774] = Fluid3D([10178,10760,9887,10569],0); -ELEMENTS[13775] = Fluid3D([10178,9887,9204,9649],0); -ELEMENTS[13776] = Fluid3D([9845,10178,9204,9755],0); -ELEMENTS[13777] = Fluid3D([10760,10178,11225,10569],0); -ELEMENTS[13778] = Fluid3D([10504,10696,11220,10658],0); -ELEMENTS[13779] = Fluid3D([9825,9755,9660,8948],0); -ELEMENTS[13780] = Fluid3D([9825,9755,8948,9567],0); -ELEMENTS[13781] = Fluid3D([9660,9825,8948,9094],0); -ELEMENTS[13782] = Fluid3D([9660,9825,9094,10400],0); -ELEMENTS[13783] = Fluid3D([9825,8948,9094,9348],0); -ELEMENTS[13784] = Fluid3D([9755,9660,8948,8936],0); -ELEMENTS[13785] = Fluid3D([9660,8948,8936,9094],0); -ELEMENTS[13786] = Fluid3D([9755,9660,8936,10017],0); -ELEMENTS[13787] = Fluid3D([8948,9755,8936,8781],0); -ELEMENTS[13788] = Fluid3D([8936,8948,8781,8116],0); -ELEMENTS[13789] = Fluid3D([8936,8948,8116,8523],0); -ELEMENTS[13790] = Fluid3D([8936,8948,8523,9094],0); -ELEMENTS[13791] = Fluid3D([8948,8523,9094,8465],0); -ELEMENTS[13792] = Fluid3D([8523,9094,8465,8448],0); -ELEMENTS[13793] = Fluid3D([8523,9094,8448,9003],0); -ELEMENTS[13794] = Fluid3D([8523,9094,9003,8854],0); -ELEMENTS[13795] = Fluid3D([9003,8523,8854,8198],0); -ELEMENTS[13796] = Fluid3D([8854,9003,8198,8800],0); -ELEMENTS[13797] = Fluid3D([8465,8523,8448,7728],0); -ELEMENTS[13798] = Fluid3D([8448,8523,9003,8198],0); -ELEMENTS[13799] = Fluid3D([9094,8448,9003,9350],0); -ELEMENTS[13800] = Fluid3D([9094,8465,8448,9063],0); -ELEMENTS[13801] = Fluid3D([8948,8781,8116,8274],0); -ELEMENTS[13802] = Fluid3D([8465,8523,7728,8116],0); -ELEMENTS[13803] = Fluid3D([8948,8116,8523,8465],0); -ELEMENTS[13804] = Fluid3D([9094,8448,9350,9063],0); -ELEMENTS[13805] = Fluid3D([8523,8448,7728,8198],0); -ELEMENTS[13806] = Fluid3D([9003,9094,9350,10400],0); -ELEMENTS[13807] = Fluid3D([8948,8781,8274,9410],0); -ELEMENTS[13808] = Fluid3D([8948,8781,9410,9755],0); -ELEMENTS[13809] = Fluid3D([9410,8948,9755,9567],0); -ELEMENTS[13810] = Fluid3D([8116,8948,8274,8465],0); -ELEMENTS[13811] = Fluid3D([8116,8936,8523,8096],0); -ELEMENTS[13812] = Fluid3D([8523,8116,8096,7728],0); -ELEMENTS[13813] = Fluid3D([8936,8523,8096,8854],0); -ELEMENTS[13814] = Fluid3D([8116,8936,8096,7831],0); -ELEMENTS[13815] = Fluid3D([8523,8096,8854,8198],0); -ELEMENTS[13816] = Fluid3D([9094,8465,9063,9348],0); -ELEMENTS[13817] = Fluid3D([9660,8936,10017,9569],0); -ELEMENTS[13818] = Fluid3D([9660,8936,9569,8854],0); -ELEMENTS[13819] = Fluid3D([9660,8936,8854,9094],0); -ELEMENTS[13820] = Fluid3D([10017,9660,9569,10538],0); -ELEMENTS[13821] = Fluid3D([9350,9094,9063,10115],0); -ELEMENTS[13822] = Fluid3D([8781,9410,9755,9204],0); -ELEMENTS[13823] = Fluid3D([8523,8936,9094,8854],0); -ELEMENTS[13824] = Fluid3D([8274,8948,9410,9567],0); -ELEMENTS[13825] = Fluid3D([8781,8936,8116,7831],0); -ELEMENTS[13826] = Fluid3D([9094,8948,8465,9348],0); -ELEMENTS[13827] = Fluid3D([8854,9003,8800,9748],0); -ELEMENTS[13828] = Fluid3D([8448,9350,9063,8489],0); -ELEMENTS[13829] = Fluid3D([8781,8274,9410,8660],0); -ELEMENTS[13830] = Fluid3D([9063,8448,8489,8212],0); -ELEMENTS[13831] = Fluid3D([8448,8465,7728,8212],0); -ELEMENTS[13832] = Fluid3D([9063,8448,8212,8465],0); -ELEMENTS[13833] = Fluid3D([8448,8489,8212,7843],0); -ELEMENTS[13834] = Fluid3D([8448,8489,7843,8532],0); -ELEMENTS[13835] = Fluid3D([8448,8489,8532,9350],0); -ELEMENTS[13836] = Fluid3D([8212,8448,7843,7728],0); -ELEMENTS[13837] = Fluid3D([8274,9410,8660,8770],0); -ELEMENTS[13838] = Fluid3D([9410,8660,8770,9474],0); -ELEMENTS[13839] = Fluid3D([9410,8660,9474,9204],0); -ELEMENTS[13840] = Fluid3D([9003,8198,8800,8533],0); -ELEMENTS[13841] = Fluid3D([8781,8274,8660,7914],0); -ELEMENTS[13842] = Fluid3D([8781,8274,7914,8116],0); -ELEMENTS[13843] = Fluid3D([8660,8781,7914,9204],0); -ELEMENTS[13844] = Fluid3D([8660,8781,9204,9410],0); -ELEMENTS[13845] = Fluid3D([8489,9063,8212,8693],0); -ELEMENTS[13846] = Fluid3D([8448,9003,9350,8532],0); -ELEMENTS[13847] = Fluid3D([9350,9063,8489,9676],0); -ELEMENTS[13848] = Fluid3D([9350,9063,9676,10115],0); -ELEMENTS[13849] = Fluid3D([9063,8489,9676,8693],0); -ELEMENTS[13850] = Fluid3D([8489,9350,9676,9451],0); -ELEMENTS[13851] = Fluid3D([8489,9350,9451,8532],0); -ELEMENTS[13852] = Fluid3D([9350,9676,9451,10273],0); -ELEMENTS[13853] = Fluid3D([9350,9676,10273,10115],0); -ELEMENTS[13854] = Fluid3D([8660,8770,9474,8648],0); -ELEMENTS[13855] = Fluid3D([8489,7843,8532,8742],0); -ELEMENTS[13856] = Fluid3D([8489,7843,8742,7722],0); -ELEMENTS[13857] = Fluid3D([8489,7843,7722,8212],0); -ELEMENTS[13858] = Fluid3D([9569,9660,8854,9748],0); -ELEMENTS[13859] = Fluid3D([8274,9410,8770,9567],0); -ELEMENTS[13860] = Fluid3D([9410,8770,9567,9474],0); -ELEMENTS[13861] = Fluid3D([7843,8448,8532,7812],0); -ELEMENTS[13862] = Fluid3D([7843,8448,7812,7728],0); -ELEMENTS[13863] = Fluid3D([8448,8532,7812,8198],0); -ELEMENTS[13864] = Fluid3D([7812,8448,8198,7728],0); -ELEMENTS[13865] = Fluid3D([8532,7843,7812,7711],0); -ELEMENTS[13866] = Fluid3D([7843,7812,7711,7071],0); -ELEMENTS[13867] = Fluid3D([7812,8532,7711,8533],0); -ELEMENTS[13868] = Fluid3D([7711,7843,7071,7280],0); -ELEMENTS[13869] = Fluid3D([8532,7843,7711,8742],0); -ELEMENTS[13870] = Fluid3D([7843,7071,7280,7095],0); -ELEMENTS[13871] = Fluid3D([7843,7071,7095,7728],0); -ELEMENTS[13872] = Fluid3D([7071,7280,7095,6463],0); -ELEMENTS[13873] = Fluid3D([7071,7280,6463,6802],0); -ELEMENTS[13874] = Fluid3D([7071,7280,6802,7711],0); -ELEMENTS[13875] = Fluid3D([7280,7095,6463,6836],0); -ELEMENTS[13876] = Fluid3D([7280,7095,6836,7722],0); -ELEMENTS[13877] = Fluid3D([6463,7280,6836,6608],0); -ELEMENTS[13878] = Fluid3D([6463,7280,6608,6802],0); -ELEMENTS[13879] = Fluid3D([7280,6836,6608,7352],0); -ELEMENTS[13880] = Fluid3D([6836,6608,7352,6417],0); -ELEMENTS[13881] = Fluid3D([6836,6608,6417,5758],0); -ELEMENTS[13882] = Fluid3D([7352,6836,6417,7237],0); -ELEMENTS[13883] = Fluid3D([7280,6836,7352,7722],0); -ELEMENTS[13884] = Fluid3D([7843,7812,7071,7728],0); -ELEMENTS[13885] = Fluid3D([7711,7843,7280,8742],0); -ELEMENTS[13886] = Fluid3D([8274,8660,7914,7844],0); -ELEMENTS[13887] = Fluid3D([7914,8274,7844,7450],0); -ELEMENTS[13888] = Fluid3D([8274,7844,7450,7818],0); -ELEMENTS[13889] = Fluid3D([8274,7844,7818,8770],0); -ELEMENTS[13890] = Fluid3D([8274,8660,7844,8770],0); -ELEMENTS[13891] = Fluid3D([7914,8274,7450,8116],0); -ELEMENTS[13892] = Fluid3D([8660,7914,7844,7965],0); -ELEMENTS[13893] = Fluid3D([7914,7844,7965,7184],0); -ELEMENTS[13894] = Fluid3D([8660,7914,7965,8506],0); -ELEMENTS[13895] = Fluid3D([8660,7914,8506,9204],0); -ELEMENTS[13896] = Fluid3D([8506,8660,9204,8997],0); -ELEMENTS[13897] = Fluid3D([9204,8506,8997,9887],0); -ELEMENTS[13898] = Fluid3D([8660,9204,8997,9474],0); -ELEMENTS[13899] = Fluid3D([8506,8660,8997,7965],0); -ELEMENTS[13900] = Fluid3D([7844,7965,7184,7418],0); -ELEMENTS[13901] = Fluid3D([7844,7965,7418,8648],0); -ELEMENTS[13902] = Fluid3D([7965,7184,7418,7185],0); -ELEMENTS[13903] = Fluid3D([7184,7418,7185,6583],0); -ELEMENTS[13904] = Fluid3D([7184,7418,6583,6946],0); -ELEMENTS[13905] = Fluid3D([7184,7418,6946,7844],0); -ELEMENTS[13906] = Fluid3D([7965,7184,7185,7493],0); -ELEMENTS[13907] = Fluid3D([7965,7184,7493,7914],0); -ELEMENTS[13908] = Fluid3D([7185,7965,7493,7849],0); -ELEMENTS[13909] = Fluid3D([7965,7493,7849,8506],0); -ELEMENTS[13910] = Fluid3D([7185,7965,7849,7889],0); -ELEMENTS[13911] = Fluid3D([7965,7849,7889,8997],0); -ELEMENTS[13912] = Fluid3D([7185,7965,7889,7418],0); -ELEMENTS[13913] = Fluid3D([7914,7844,7184,7450],0); -ELEMENTS[13914] = Fluid3D([7844,8660,7965,8648],0); -ELEMENTS[13915] = Fluid3D([7095,7071,6463,6498],0); -ELEMENTS[13916] = Fluid3D([7095,7071,6498,7728],0); -ELEMENTS[13917] = Fluid3D([7071,6463,6498,6220],0); -ELEMENTS[13918] = Fluid3D([7071,6463,6220,6802],0); -ELEMENTS[13919] = Fluid3D([6463,7095,6498,6318],0); -ELEMENTS[13920] = Fluid3D([6463,7095,6318,6836],0); -ELEMENTS[13921] = Fluid3D([6498,6463,6318,5998],0); -ELEMENTS[13922] = Fluid3D([6463,6318,5998,5758],0); -ELEMENTS[13923] = Fluid3D([6498,6463,5998,6220],0); -ELEMENTS[13924] = Fluid3D([7095,6498,6318,6824],0); -ELEMENTS[13925] = Fluid3D([7095,6498,6824,7728],0); -ELEMENTS[13926] = Fluid3D([6498,6318,6824,6055],0); -ELEMENTS[13927] = Fluid3D([6824,6498,6055,6605],0); -ELEMENTS[13928] = Fluid3D([6824,6498,6605,7728],0); -ELEMENTS[13929] = Fluid3D([6498,6318,6055,5998],0); -ELEMENTS[13930] = Fluid3D([6318,7095,6824,7195],0); -ELEMENTS[13931] = Fluid3D([6318,7095,7195,6836],0); -ELEMENTS[13932] = Fluid3D([7095,6824,7195,7668],0); -ELEMENTS[13933] = Fluid3D([6824,6318,7195,6465],0); -ELEMENTS[13934] = Fluid3D([6824,7195,7668,7198],0); -ELEMENTS[13935] = Fluid3D([6824,7195,7198,6465],0); -ELEMENTS[13936] = Fluid3D([6318,7195,6465,6854],0); -ELEMENTS[13937] = Fluid3D([7195,6465,6854,7292],0); -ELEMENTS[13938] = Fluid3D([7195,6465,7292,7198],0); -ELEMENTS[13939] = Fluid3D([7095,6824,7668,7728],0); -ELEMENTS[13940] = Fluid3D([6318,6824,6055,5801],0); -ELEMENTS[13941] = Fluid3D([6498,7071,6220,6810],0); -ELEMENTS[13942] = Fluid3D([6498,7071,6810,7728],0); -ELEMENTS[13943] = Fluid3D([7071,6220,6810,6925],0); -ELEMENTS[13944] = Fluid3D([7071,6220,6925,6802],0); -ELEMENTS[13945] = Fluid3D([6810,7071,6925,7812],0); -ELEMENTS[13946] = Fluid3D([6220,6498,6810,5926],0); -ELEMENTS[13947] = Fluid3D([6498,6810,5926,6605],0); -ELEMENTS[13948] = Fluid3D([6220,6498,5926,5998],0); -ELEMENTS[13949] = Fluid3D([6810,6220,5926,5885],0); -ELEMENTS[13950] = Fluid3D([6220,6810,6925,5954],0); -ELEMENTS[13951] = Fluid3D([7195,7095,7668,7722],0); -ELEMENTS[13952] = Fluid3D([7493,7185,7849,6908],0); -ELEMENTS[13953] = Fluid3D([11029,10982,11876,11718],0); -ELEMENTS[13954] = Fluid3D([11029,10982,11718,10772],0); -ELEMENTS[13955] = Fluid3D([11876,11029,11718,11989],0); -ELEMENTS[13956] = Fluid3D([11029,11718,11989,11004],0); -ELEMENTS[13957] = Fluid3D([10982,11876,11718,12007],0); -ELEMENTS[13958] = Fluid3D([11718,10982,12007,11558],0); -ELEMENTS[13959] = Fluid3D([10982,11876,12007,11488],0); -ELEMENTS[13960] = Fluid3D([12007,11718,11558,12364],0); -ELEMENTS[13961] = Fluid3D([11718,11558,12364,11676],0); -ELEMENTS[13962] = Fluid3D([11718,11558,11676,10772],0); -ELEMENTS[13963] = Fluid3D([12007,11718,12364,12654],0); -ELEMENTS[13964] = Fluid3D([12007,11718,12654,11876],0); -ELEMENTS[13965] = Fluid3D([11718,12364,12654,12493],0); -ELEMENTS[13966] = Fluid3D([11718,12364,12493,11676],0); -ELEMENTS[13967] = Fluid3D([12654,11718,12493,11989],0); -ELEMENTS[13968] = Fluid3D([11718,10982,11558,10772],0); -ELEMENTS[13969] = Fluid3D([12364,12654,12493,13240],0); -ELEMENTS[13970] = Fluid3D([12654,12493,13240,13214],0); -ELEMENTS[13971] = Fluid3D([12364,12654,13240,13011],0); -ELEMENTS[13972] = Fluid3D([12364,12654,13011,12007],0); -ELEMENTS[13973] = Fluid3D([13240,12654,13214,13563],0); -ELEMENTS[13974] = Fluid3D([12654,13214,13563,13035],0); -ELEMENTS[13975] = Fluid3D([12654,13214,13035,11989],0); -ELEMENTS[13976] = Fluid3D([13240,12654,13563,13011],0); -ELEMENTS[13977] = Fluid3D([12493,12364,13240,12776],0); -ELEMENTS[13978] = Fluid3D([12493,12364,12776,11676],0); -ELEMENTS[13979] = Fluid3D([12364,13240,12776,13183],0); -ELEMENTS[13980] = Fluid3D([12776,12364,13183,12433],0); -ELEMENTS[13981] = Fluid3D([12364,13240,13183,13011],0); -ELEMENTS[13982] = Fluid3D([12654,12493,13214,11989],0); -ELEMENTS[13983] = Fluid3D([13240,12776,13183,13675],0); -ELEMENTS[13984] = Fluid3D([12776,13183,13675,13150],0); -ELEMENTS[13985] = Fluid3D([13183,13675,13150,13899],0); -ELEMENTS[13986] = Fluid3D([13675,13150,13899,14282],0); -ELEMENTS[13987] = Fluid3D([13240,12776,13675,13418],0); -ELEMENTS[13988] = Fluid3D([12776,13675,13418,13329],0); -ELEMENTS[13989] = Fluid3D([12776,13675,13329,13150],0); -ELEMENTS[13990] = Fluid3D([13240,12776,13418,12493],0); -ELEMENTS[13991] = Fluid3D([12776,13183,13150,12433],0); -ELEMENTS[13992] = Fluid3D([13183,13240,13675,13877],0); -ELEMENTS[13993] = Fluid3D([13183,13240,13877,13011],0); -ELEMENTS[13994] = Fluid3D([13240,13675,13877,14092],0); -ELEMENTS[13995] = Fluid3D([13675,13877,14092,14736],0); -ELEMENTS[13996] = Fluid3D([13877,13240,14092,13563],0); -ELEMENTS[13997] = Fluid3D([13240,13675,14092,13418],0); -ELEMENTS[13998] = Fluid3D([11876,11029,11989,11322],0); -ELEMENTS[13999] = Fluid3D([11718,11876,11989,12654],0); -ELEMENTS[14000] = Fluid3D([11558,12364,11676,12433],0); -ELEMENTS[14001] = Fluid3D([10982,12007,11558,11244],0); -ELEMENTS[14002] = Fluid3D([10982,12007,11244,11488],0); -ELEMENTS[14003] = Fluid3D([11558,10982,11244,10273],0); -ELEMENTS[14004] = Fluid3D([12007,11558,11244,12029],0); -ELEMENTS[14005] = Fluid3D([11244,12007,12029,12144],0); -ELEMENTS[14006] = Fluid3D([11244,12007,12144,11488],0); -ELEMENTS[14007] = Fluid3D([12029,11244,12144,11653],0); -ELEMENTS[14008] = Fluid3D([12029,11244,11653,11136],0); -ELEMENTS[14009] = Fluid3D([11244,12144,11653,11310],0); -ELEMENTS[14010] = Fluid3D([11244,11653,11136,10613],0); -ELEMENTS[14011] = Fluid3D([12007,11558,12029,12364],0); -ELEMENTS[14012] = Fluid3D([11244,11653,10613,11310],0); -ELEMENTS[14013] = Fluid3D([12029,11244,11136,11558],0); -ELEMENTS[14014] = Fluid3D([11244,12144,11310,11488],0); -ELEMENTS[14015] = Fluid3D([12007,12029,12144,13011],0); -ELEMENTS[14016] = Fluid3D([12144,12029,11653,12637],0); -ELEMENTS[14017] = Fluid3D([12029,11653,12637,12103],0); -ELEMENTS[14018] = Fluid3D([11653,12144,12637,12249],0); -ELEMENTS[14019] = Fluid3D([12637,11653,12249,12229],0); -ELEMENTS[14020] = Fluid3D([12637,12029,12103,12870],0); -ELEMENTS[14021] = Fluid3D([12144,12029,12637,13011],0); -ELEMENTS[14022] = Fluid3D([12637,12029,12870,13011],0); -ELEMENTS[14023] = Fluid3D([11653,12144,12249,11310],0); -ELEMENTS[14024] = Fluid3D([12637,11653,12229,12103],0); -ELEMENTS[14025] = Fluid3D([12029,11653,12103,11136],0); -ELEMENTS[14026] = Fluid3D([12249,12637,12229,13061],0); -ELEMENTS[14027] = Fluid3D([12637,12229,13061,13155],0); -ELEMENTS[14028] = Fluid3D([12249,12637,13061,13063],0); -ELEMENTS[14029] = Fluid3D([12249,12637,13063,12144],0); -ELEMENTS[14030] = Fluid3D([12229,12249,13061,12406],0); -ELEMENTS[14031] = Fluid3D([13061,12229,12406,12796],0); -ELEMENTS[14032] = Fluid3D([13061,12229,12796,13155],0); -ELEMENTS[14033] = Fluid3D([12229,12406,12796,11845],0); -ELEMENTS[14034] = Fluid3D([12796,12229,11845,12230],0); -ELEMENTS[14035] = Fluid3D([12796,12229,12230,13155],0); -ELEMENTS[14036] = Fluid3D([12406,13061,12796,13360],0); -ELEMENTS[14037] = Fluid3D([12229,12249,12406,11492],0); -ELEMENTS[14038] = Fluid3D([12229,12249,11492,11653],0); -ELEMENTS[14039] = Fluid3D([13061,12249,13063,13020],0); -ELEMENTS[14040] = Fluid3D([13063,13061,13020,13750],0); -ELEMENTS[14041] = Fluid3D([13063,13061,13750,13634],0); -ELEMENTS[14042] = Fluid3D([13063,13061,13634,12637],0); -ELEMENTS[14043] = Fluid3D([13061,12249,13020,12406],0); -ELEMENTS[14044] = Fluid3D([12249,13063,13020,12466],0); -ELEMENTS[14045] = Fluid3D([12249,13063,12466,12144],0); -ELEMENTS[14046] = Fluid3D([13063,13020,12466,13392],0); -ELEMENTS[14047] = Fluid3D([13063,13020,13392,13750],0); -ELEMENTS[14048] = Fluid3D([12466,13063,13392,13009],0); -ELEMENTS[14049] = Fluid3D([12466,13063,13009,12144],0); -ELEMENTS[14050] = Fluid3D([13063,13392,13009,14066],0); -ELEMENTS[14051] = Fluid3D([13063,13392,14066,13750],0); -ELEMENTS[14052] = Fluid3D([13392,13009,14066,13760],0); -ELEMENTS[14053] = Fluid3D([13009,14066,13760,13668],0); -ELEMENTS[14054] = Fluid3D([13392,13009,13760,12958],0); -ELEMENTS[14055] = Fluid3D([13009,14066,13668,13257],0); -ELEMENTS[14056] = Fluid3D([13009,14066,13257,13063],0); -ELEMENTS[14057] = Fluid3D([13392,13009,12958,12466],0); -ELEMENTS[14058] = Fluid3D([12249,12406,11492,11868],0); -ELEMENTS[14059] = Fluid3D([11492,12249,11868,11310],0); -ELEMENTS[14060] = Fluid3D([12249,12406,11868,13020],0); -ELEMENTS[14061] = Fluid3D([12406,11492,11868,11511],0); -ELEMENTS[14062] = Fluid3D([12406,11492,11511,12456],0); -ELEMENTS[14063] = Fluid3D([11868,12406,11511,12435],0); -ELEMENTS[14064] = Fluid3D([12406,11511,12435,12456],0); -ELEMENTS[14065] = Fluid3D([11868,12406,12435,13020],0); -ELEMENTS[14066] = Fluid3D([11492,11868,11511,10891],0); -ELEMENTS[14067] = Fluid3D([11492,11868,10891,11310],0); -ELEMENTS[14068] = Fluid3D([11511,11492,10891,10838],0); -ELEMENTS[14069] = Fluid3D([11492,10891,10838,10337],0); -ELEMENTS[14070] = Fluid3D([11868,11511,10891,11442],0); -ELEMENTS[14071] = Fluid3D([11868,11511,11442,12435],0); -ELEMENTS[14072] = Fluid3D([11511,10891,11442,10839],0); -ELEMENTS[14073] = Fluid3D([10891,11442,10839,10200],0); -ELEMENTS[14074] = Fluid3D([10839,10891,10200,10838],0); -ELEMENTS[14075] = Fluid3D([10891,10200,10838,10337],0); -ELEMENTS[14076] = Fluid3D([10891,10200,10337,10469],0); -ELEMENTS[14077] = Fluid3D([10891,10200,10469,10764],0); -ELEMENTS[14078] = Fluid3D([10891,10200,10764,11442],0); -ELEMENTS[14079] = Fluid3D([10764,10891,11442,11868],0); -ELEMENTS[14080] = Fluid3D([10469,10891,10764,11868],0); -ELEMENTS[14081] = Fluid3D([10200,10469,10764,10005],0); -ELEMENTS[14082] = Fluid3D([10337,10891,10469,11310],0); -ELEMENTS[14083] = Fluid3D([10200,10337,10469,9748],0); -ELEMENTS[14084] = Fluid3D([11511,10891,10839,10838],0); -ELEMENTS[14085] = Fluid3D([13020,12466,13392,12519],0); -ELEMENTS[14086] = Fluid3D([11511,11492,10838,11845],0); -ELEMENTS[14087] = Fluid3D([13020,12249,12466,11868],0); -ELEMENTS[14088] = Fluid3D([13750,13063,13634,14066],0); -ELEMENTS[14089] = Fluid3D([11442,11511,10839,11133],0); -ELEMENTS[14090] = Fluid3D([12406,12229,11492,11845],0); -ELEMENTS[14091] = Fluid3D([10690,11283,11632,10770],0); -ELEMENTS[14092] = Fluid3D([12931,11969,12423,12883],0); -ELEMENTS[14093] = Fluid3D([12475,11283,11942,12012],0); -ELEMENTS[14094] = Fluid3D([12475,11283,12012,11632],0); -ELEMENTS[14095] = Fluid3D([11283,11942,12012,10689],0); -ELEMENTS[14096] = Fluid3D([11942,12475,12012,12811],0); -ELEMENTS[14097] = Fluid3D([12012,11942,12811,12274],0); -ELEMENTS[14098] = Fluid3D([11942,12475,12811,12627],0); -ELEMENTS[14099] = Fluid3D([11942,12811,12274,12687],0); -ELEMENTS[14100] = Fluid3D([12811,12274,12687,13212],0); -ELEMENTS[14101] = Fluid3D([12687,12811,13212,13526],0); -ELEMENTS[14102] = Fluid3D([11942,12811,12687,12627],0); -ELEMENTS[14103] = Fluid3D([12274,11942,12687,11781],0); -ELEMENTS[14104] = Fluid3D([11942,12687,11781,12023],0); -ELEMENTS[14105] = Fluid3D([11942,12687,12023,12627],0); -ELEMENTS[14106] = Fluid3D([12274,11942,11781,10689],0); -ELEMENTS[14107] = Fluid3D([12687,12811,13526,12627],0); -ELEMENTS[14108] = Fluid3D([12811,12274,13212,12866],0); -ELEMENTS[14109] = Fluid3D([12811,12274,12866,12012],0); -ELEMENTS[14110] = Fluid3D([12274,13212,12866,12773],0); -ELEMENTS[14111] = Fluid3D([12866,12274,12773,12044],0); -ELEMENTS[14112] = Fluid3D([12866,12274,12044,12012],0); -ELEMENTS[14113] = Fluid3D([12274,13212,12773,12669],0); -ELEMENTS[14114] = Fluid3D([13212,12773,12669,13487],0); -ELEMENTS[14115] = Fluid3D([12274,13212,12669,12687],0); -ELEMENTS[14116] = Fluid3D([13212,12773,13487,13642],0); -ELEMENTS[14117] = Fluid3D([12773,13487,13642,13400],0); -ELEMENTS[14118] = Fluid3D([12773,13487,13400,12788],0); -ELEMENTS[14119] = Fluid3D([12773,13487,12788,12669],0); -ELEMENTS[14120] = Fluid3D([13212,12773,13642,12866],0); -ELEMENTS[14121] = Fluid3D([13212,12811,12866,13624],0); -ELEMENTS[14122] = Fluid3D([12811,12866,13624,13003],0); -ELEMENTS[14123] = Fluid3D([13212,12811,13624,13526],0); -ELEMENTS[14124] = Fluid3D([13624,12811,13003,13660],0); -ELEMENTS[14125] = Fluid3D([13624,12811,13660,13526],0); -ELEMENTS[14126] = Fluid3D([12811,13003,13660,12475],0); -ELEMENTS[14127] = Fluid3D([12866,13212,13624,13642],0); -ELEMENTS[14128] = Fluid3D([12811,12866,13003,12012],0); -ELEMENTS[14129] = Fluid3D([12475,12012,12811,13003],0); -ELEMENTS[14130] = Fluid3D([12274,12773,12044,11849],0); -ELEMENTS[14131] = Fluid3D([12044,12274,11849,11307],0); -ELEMENTS[14132] = Fluid3D([11849,12044,11307,10581],0); -ELEMENTS[14133] = Fluid3D([12274,12773,11849,12669],0); -ELEMENTS[14134] = Fluid3D([12044,12274,11307,12012],0); -ELEMENTS[14135] = Fluid3D([12773,12044,11849,12191],0); -ELEMENTS[14136] = Fluid3D([12044,11849,12191,11587],0); -ELEMENTS[14137] = Fluid3D([12191,12044,11587,12148],0); -ELEMENTS[14138] = Fluid3D([12773,12044,12191,12815],0); -ELEMENTS[14139] = Fluid3D([12773,12044,12815,12866],0); -ELEMENTS[14140] = Fluid3D([12191,12773,12815,13400],0); -ELEMENTS[14141] = Fluid3D([11849,12773,12191,12788],0); -ELEMENTS[14142] = Fluid3D([12044,12191,12815,12148],0); -ELEMENTS[14143] = Fluid3D([12274,11849,11307,11781],0); -ELEMENTS[14144] = Fluid3D([13212,12687,13526,13479],0); -ELEMENTS[14145] = Fluid3D([13526,13212,13479,14072],0); -ELEMENTS[14146] = Fluid3D([13212,12687,13479,12669],0); -ELEMENTS[14147] = Fluid3D([12687,13526,13479,13318],0); -ELEMENTS[14148] = Fluid3D([13479,12687,13318,12758],0); -ELEMENTS[14149] = Fluid3D([13479,12687,12758,12669],0); -ELEMENTS[14150] = Fluid3D([12687,13526,13318,12627],0); -ELEMENTS[14151] = Fluid3D([13212,13479,14072,13487],0); -ELEMENTS[14152] = Fluid3D([13526,13479,13318,14115],0); -ELEMENTS[14153] = Fluid3D([13526,13479,14115,14072],0); -ELEMENTS[14154] = Fluid3D([13479,13318,14115,13418],0); -ELEMENTS[14155] = Fluid3D([13318,13526,14115,13791],0); -ELEMENTS[14156] = Fluid3D([13526,14115,13791,14296],0); -ELEMENTS[14157] = Fluid3D([13318,13526,13791,12627],0); -ELEMENTS[14158] = Fluid3D([13791,13526,14296,13660],0); -ELEMENTS[14159] = Fluid3D([14115,13318,13791,13919],0); -ELEMENTS[14160] = Fluid3D([13791,14115,13919,14661],0); -ELEMENTS[14161] = Fluid3D([13318,13791,13919,12869],0); -ELEMENTS[14162] = Fluid3D([14115,13318,13919,13793],0); -ELEMENTS[14163] = Fluid3D([13318,13919,13793,13214],0); -ELEMENTS[14164] = Fluid3D([13793,13318,13214,13418],0); -ELEMENTS[14165] = Fluid3D([13214,13793,13418,14092],0); -ELEMENTS[14166] = Fluid3D([13793,13418,14092,14229],0); -ELEMENTS[14167] = Fluid3D([13793,13418,14229,14115],0); -ELEMENTS[14168] = Fluid3D([14092,13793,14229,14541],0); -ELEMENTS[14169] = Fluid3D([14092,13793,14541,14004],0); -ELEMENTS[14170] = Fluid3D([14092,13793,14004,13214],0); -ELEMENTS[14171] = Fluid3D([13793,14004,13214,13919],0); -ELEMENTS[14172] = Fluid3D([13793,14004,13919,14541],0); -ELEMENTS[14173] = Fluid3D([13793,14229,14541,14115],0); -ELEMENTS[14174] = Fluid3D([14004,13214,13919,13035],0); -ELEMENTS[14175] = Fluid3D([14541,14092,14004,14713],0); -ELEMENTS[14176] = Fluid3D([14092,14004,14713,13563],0); -ELEMENTS[14177] = Fluid3D([14541,14092,14713,14864],0); -ELEMENTS[14178] = Fluid3D([14541,14092,14864,14229],0); -ELEMENTS[14179] = Fluid3D([14092,14713,14864,14567],0); -ELEMENTS[14180] = Fluid3D([14092,14713,14567,13877],0); -ELEMENTS[14181] = Fluid3D([14567,14092,13877,14736],0); -ELEMENTS[14182] = Fluid3D([14864,14092,14567,14736],0); -ELEMENTS[14183] = Fluid3D([14004,13919,14541,14701],0); -ELEMENTS[14184] = Fluid3D([14004,14541,14713,14701],0); -ELEMENTS[14185] = Fluid3D([14713,14541,14864,15463],0); -ELEMENTS[14186] = Fluid3D([14713,14864,14567,15282],0); -ELEMENTS[14187] = Fluid3D([14567,14713,15282,14874],0); -ELEMENTS[14188] = Fluid3D([14567,14713,14874,13877],0); -ELEMENTS[14189] = Fluid3D([14713,14864,15282,15463],0); -ELEMENTS[14190] = Fluid3D([14864,14567,15282,15447],0); -ELEMENTS[14191] = Fluid3D([14115,13318,13793,13418],0); -ELEMENTS[14192] = Fluid3D([13791,14115,14661,14296],0); -ELEMENTS[14193] = Fluid3D([13526,14115,14296,14072],0); -ELEMENTS[14194] = Fluid3D([13526,13212,14072,13624],0); -ELEMENTS[14195] = Fluid3D([14115,13919,14661,14541],0); -ELEMENTS[14196] = Fluid3D([12012,11942,12274,10689],0); -ELEMENTS[14197] = Fluid3D([13487,13212,13642,14072],0); -ELEMENTS[14198] = Fluid3D([11663,12188,12627,12063],0); -ELEMENTS[14199] = Fluid3D([12687,12274,11781,12669],0); -ELEMENTS[14200] = Fluid3D([13003,13624,13660,13874],0); -ELEMENTS[14201] = Fluid3D([13003,13624,13874,13591],0); -ELEMENTS[14202] = Fluid3D([13624,13874,13591,14339],0); -ELEMENTS[14203] = Fluid3D([13660,13003,13874,13203],0); -ELEMENTS[14204] = Fluid3D([13874,13660,13203,13871],0); -ELEMENTS[14205] = Fluid3D([13874,13591,14339,14261],0); -ELEMENTS[14206] = Fluid3D([13874,13591,14261,13463],0); -ELEMENTS[14207] = Fluid3D([13874,13591,13463,13003],0); -ELEMENTS[14208] = Fluid3D([13591,14339,14261,14267],0); -ELEMENTS[14209] = Fluid3D([13591,14339,14267,13642],0); -ELEMENTS[14210] = Fluid3D([14339,14261,14267,14995],0); -ELEMENTS[14211] = Fluid3D([13624,13874,14339,14371],0); -ELEMENTS[14212] = Fluid3D([13624,13874,14371,13660],0); -ELEMENTS[14213] = Fluid3D([13874,14339,14371,14720],0); -ELEMENTS[14214] = Fluid3D([14339,13624,14371,14072],0); -ELEMENTS[14215] = Fluid3D([14339,14371,14720,14992],0); -ELEMENTS[14216] = Fluid3D([14371,14720,14992,14983],0); -ELEMENTS[14217] = Fluid3D([14371,14720,14983,14343],0); -ELEMENTS[14218] = Fluid3D([14371,14720,14343,13874],0); -ELEMENTS[14219] = Fluid3D([14339,14371,14992,14072],0); -ELEMENTS[14220] = Fluid3D([13874,14339,14720,14261],0); -ELEMENTS[14221] = Fluid3D([13660,13003,13203,12475],0); -ELEMENTS[14222] = Fluid3D([14261,13591,14267,13732],0); -ELEMENTS[14223] = Fluid3D([14267,14261,13732,14522],0); -ELEMENTS[14224] = Fluid3D([14261,13591,13732,13463],0); -ELEMENTS[14225] = Fluid3D([13591,14267,13732,13461],0); -ELEMENTS[14226] = Fluid3D([14267,13732,13461,13615],0); -ELEMENTS[14227] = Fluid3D([13591,14267,13461,13642],0); -ELEMENTS[14228] = Fluid3D([13732,13591,13461,12875],0); -ELEMENTS[14229] = Fluid3D([13732,13591,12875,13463],0); -ELEMENTS[14230] = Fluid3D([13461,13732,12875,12712],0); -ELEMENTS[14231] = Fluid3D([13591,13461,12875,12866],0); -ELEMENTS[14232] = Fluid3D([13003,13624,13591,12866],0); -ELEMENTS[14233] = Fluid3D([13591,13624,14339,13642],0); -ELEMENTS[14234] = Fluid3D([13003,13874,13203,13463],0); -ELEMENTS[14235] = Fluid3D([14261,13874,13463,14161],0); -ELEMENTS[14236] = Fluid3D([14261,13874,14161,14720],0); -ELEMENTS[14237] = Fluid3D([13874,13463,14161,13203],0); -ELEMENTS[14238] = Fluid3D([13463,14261,14161,14051],0); -ELEMENTS[14239] = Fluid3D([14161,13463,14051,13529],0); -ELEMENTS[14240] = Fluid3D([13463,14051,13529,13184],0); -ELEMENTS[14241] = Fluid3D([14051,13529,13184,14232],0); -ELEMENTS[14242] = Fluid3D([13463,14051,13184,13732],0); -ELEMENTS[14243] = Fluid3D([13463,14261,14051,13732],0); -ELEMENTS[14244] = Fluid3D([14161,13463,13529,13203],0); -ELEMENTS[14245] = Fluid3D([14051,14161,13529,14431],0); -ELEMENTS[14246] = Fluid3D([14261,14161,14051,14726],0); -ELEMENTS[14247] = Fluid3D([14161,14051,14726,14431],0); -ELEMENTS[14248] = Fluid3D([14051,14261,14726,14522],0); -ELEMENTS[14249] = Fluid3D([14726,14051,14522,14232],0); -ELEMENTS[14250] = Fluid3D([14726,14051,14232,14431],0); -ELEMENTS[14251] = Fluid3D([14051,14522,14232,13275],0); -ELEMENTS[14252] = Fluid3D([13529,13463,13184,12684],0); -ELEMENTS[14253] = Fluid3D([13529,13463,12684,13203],0); -ELEMENTS[14254] = Fluid3D([13463,13184,12684,12875],0); -ELEMENTS[14255] = Fluid3D([13184,13529,12684,12807],0); -ELEMENTS[14256] = Fluid3D([13529,12684,12807,12837],0); -ELEMENTS[14257] = Fluid3D([12684,12807,12837,11995],0); -ELEMENTS[14258] = Fluid3D([12684,12807,11995,11999],0); -ELEMENTS[14259] = Fluid3D([12807,11995,11999,11650],0); -ELEMENTS[14260] = Fluid3D([13184,13529,12807,13651],0); -ELEMENTS[14261] = Fluid3D([13529,12807,13651,13492],0); -ELEMENTS[14262] = Fluid3D([12807,13651,13492,12601],0); -ELEMENTS[14263] = Fluid3D([12807,12837,11995,12422],0); -ELEMENTS[14264] = Fluid3D([12837,11995,12422,12034],0); -ELEMENTS[14265] = Fluid3D([12837,11995,12034,12164],0); -ELEMENTS[14266] = Fluid3D([12807,12837,12422,13492],0); -ELEMENTS[14267] = Fluid3D([13184,13529,13651,14232],0); -ELEMENTS[14268] = Fluid3D([13529,12807,13492,12837],0); -ELEMENTS[14269] = Fluid3D([11995,12807,12422,11650],0); -ELEMENTS[14270] = Fluid3D([12684,13184,12807,12343],0); -ELEMENTS[14271] = Fluid3D([12837,12684,11995,12164],0); -ELEMENTS[14272] = Fluid3D([13529,12684,12837,13203],0); -ELEMENTS[14273] = Fluid3D([11995,12422,12034,11425],0); -ELEMENTS[14274] = Fluid3D([11995,12422,11425,11650],0); -ELEMENTS[14275] = Fluid3D([12422,11425,11650,11795],0); -ELEMENTS[14276] = Fluid3D([11425,11650,11795,10664],0); -ELEMENTS[14277] = Fluid3D([11425,11650,10664,11011],0); -ELEMENTS[14278] = Fluid3D([11425,11650,11011,11995],0); -ELEMENTS[14279] = Fluid3D([10664,11425,11011,10918],0); -ELEMENTS[14280] = Fluid3D([11425,11011,10918,11995],0); -ELEMENTS[14281] = Fluid3D([12422,11425,11795,12034],0); -ELEMENTS[14282] = Fluid3D([12034,11995,11425,10918],0); -ELEMENTS[14283] = Fluid3D([12807,13184,13651,12937],0); -ELEMENTS[14284] = Fluid3D([12807,13184,12937,12343],0); -ELEMENTS[14285] = Fluid3D([13184,13651,12937,13275],0); -ELEMENTS[14286] = Fluid3D([12937,13184,13275,12343],0); -ELEMENTS[14287] = Fluid3D([13651,12807,12937,12601],0); -ELEMENTS[14288] = Fluid3D([13184,13275,12343,12875],0); -ELEMENTS[14289] = Fluid3D([13651,13529,13492,14431],0); -ELEMENTS[14290] = Fluid3D([12423,11969,11506,11540],0); -ELEMENTS[14291] = Fluid3D([12475,12423,11540,12164],0); -ELEMENTS[14292] = Fluid3D([13675,13418,13329,14229],0); -ELEMENTS[14293] = Fluid3D([12063,12021,12462,11322],0); -ELEMENTS[14294] = Fluid3D([15334,15111,14632,15423],0); -ELEMENTS[14295] = Fluid3D([15111,14632,15423,14814],0); -ELEMENTS[14296] = Fluid3D([14632,15423,14814,14927],0); -ELEMENTS[14297] = Fluid3D([15423,14814,14927,15389],0); -ELEMENTS[14298] = Fluid3D([15423,14814,15389,15551],0); -ELEMENTS[14299] = Fluid3D([15334,15111,15423,15764],0); -ELEMENTS[14300] = Fluid3D([14814,14927,15389,14665],0); -ELEMENTS[14301] = Fluid3D([14814,14927,14665,14350],0); -ELEMENTS[14302] = Fluid3D([15389,14814,14665,15057],0); -ELEMENTS[14303] = Fluid3D([14665,15389,15057,14983],0); -ELEMENTS[14304] = Fluid3D([15057,14665,14983,14343],0); -ELEMENTS[14305] = Fluid3D([14983,15057,14343,15375],0); -ELEMENTS[14306] = Fluid3D([15389,14814,15057,15551],0); -ELEMENTS[14307] = Fluid3D([14927,15389,14665,15106],0); -ELEMENTS[14308] = Fluid3D([14665,14927,15106,14350],0); -ELEMENTS[14309] = Fluid3D([15389,14665,15106,15249],0); -ELEMENTS[14310] = Fluid3D([14665,15106,15249,14661],0); -ELEMENTS[14311] = Fluid3D([15389,14665,15249,14983],0); -ELEMENTS[14312] = Fluid3D([14927,15389,15106,15714],0); -ELEMENTS[14313] = Fluid3D([15389,15106,15714,15765],0); -ELEMENTS[14314] = Fluid3D([15106,15714,15765,15604],0); -ELEMENTS[14315] = Fluid3D([14927,15389,15714,15423],0); -ELEMENTS[14316] = Fluid3D([14665,15249,14983,14296],0); -ELEMENTS[14317] = Fluid3D([14814,14665,15057,14309],0); -ELEMENTS[14318] = Fluid3D([15106,14927,15714,15060],0); -ELEMENTS[14319] = Fluid3D([15714,15106,15060,15604],0); -ELEMENTS[14320] = Fluid3D([15106,14927,15060,14350],0); -ELEMENTS[14321] = Fluid3D([14927,15714,15060,15257],0); -ELEMENTS[14322] = Fluid3D([15714,15060,15257,15604],0); -ELEMENTS[14323] = Fluid3D([14927,15714,15257,15423],0); -ELEMENTS[14324] = Fluid3D([15060,14927,15257,14350],0); -ELEMENTS[14325] = Fluid3D([14632,15423,14927,15257],0); -ELEMENTS[14326] = Fluid3D([14632,15334,15423,15257],0); -ELEMENTS[14327] = Fluid3D([15111,14632,14814,14252],0); -ELEMENTS[14328] = Fluid3D([15423,15111,14814,15551],0); -ELEMENTS[14329] = Fluid3D([15106,15389,15249,15755],0); -ELEMENTS[14330] = Fluid3D([15249,15106,15755,15419],0); -ELEMENTS[14331] = Fluid3D([15755,15249,15419,16027],0); -ELEMENTS[14332] = Fluid3D([15106,15389,15755,15765],0); -ELEMENTS[14333] = Fluid3D([15755,15106,15765,15419],0); -ELEMENTS[14334] = Fluid3D([15249,15106,15419,14661],0); -ELEMENTS[14335] = Fluid3D([15389,15249,15755,15799],0); -ELEMENTS[14336] = Fluid3D([14814,14632,14927,14350],0); -ELEMENTS[14337] = Fluid3D([12627,12423,12475,13660],0); -ELEMENTS[14338] = Fluid3D([9079,9806,9420,8897],0); -ELEMENTS[14339] = Fluid3D([9079,9806,8897,9226],0); -ELEMENTS[14340] = Fluid3D([9420,9079,8897,8429],0); -ELEMENTS[14341] = Fluid3D([9079,8897,8429,8208],0); -ELEMENTS[14342] = Fluid3D([8897,8429,8208,7616],0); -ELEMENTS[14343] = Fluid3D([9420,9079,8429,9191],0); -ELEMENTS[14344] = Fluid3D([8429,9079,8208,8505],0); -ELEMENTS[14345] = Fluid3D([9079,8897,8208,9226],0); -ELEMENTS[14346] = Fluid3D([8897,9420,8429,8806],0); -ELEMENTS[14347] = Fluid3D([8897,9420,8806,9622],0); -ELEMENTS[14348] = Fluid3D([9420,8806,9622,9672],0); -ELEMENTS[14349] = Fluid3D([8806,9622,9672,9308],0); -ELEMENTS[14350] = Fluid3D([8806,9622,9308,8468],0); -ELEMENTS[14351] = Fluid3D([9672,8806,9308,8920],0); -ELEMENTS[14352] = Fluid3D([9622,9672,9308,10873],0); -ELEMENTS[14353] = Fluid3D([8806,9308,8920,8156],0); -ELEMENTS[14354] = Fluid3D([9308,9672,8920,9640],0); -ELEMENTS[14355] = Fluid3D([9308,9672,9640,10873],0); -ELEMENTS[14356] = Fluid3D([8920,9308,9640,8753],0); -ELEMENTS[14357] = Fluid3D([9672,8920,9640,9653],0); -ELEMENTS[14358] = Fluid3D([9640,9672,9653,10571],0); -ELEMENTS[14359] = Fluid3D([9672,8806,8920,8961],0); -ELEMENTS[14360] = Fluid3D([9672,8920,9653,8961],0); -ELEMENTS[14361] = Fluid3D([8806,8920,8961,8125],0); -ELEMENTS[14362] = Fluid3D([8806,8920,8125,8156],0); -ELEMENTS[14363] = Fluid3D([8920,8961,8125,8518],0); -ELEMENTS[14364] = Fluid3D([9653,9640,10571,10330],0); -ELEMENTS[14365] = Fluid3D([8920,8961,8518,9653],0); -ELEMENTS[14366] = Fluid3D([9640,10571,10330,10812],0); -ELEMENTS[14367] = Fluid3D([8920,9640,9653,9230],0); -ELEMENTS[14368] = Fluid3D([10330,9640,10812,10077],0); -ELEMENTS[14369] = Fluid3D([10330,9640,10077,9230],0); -ELEMENTS[14370] = Fluid3D([8920,9640,9230,8753],0); -ELEMENTS[14371] = Fluid3D([9640,10571,10812,10873],0); -ELEMENTS[14372] = Fluid3D([9653,9640,10330,9230],0); -ELEMENTS[14373] = Fluid3D([9640,10812,10077,10229],0); -ELEMENTS[14374] = Fluid3D([9640,10812,10229,10873],0); -ELEMENTS[14375] = Fluid3D([9672,9653,10571,9998],0); -ELEMENTS[14376] = Fluid3D([9672,9653,9998,8961],0); -ELEMENTS[14377] = Fluid3D([8961,8806,8125,8429],0); -ELEMENTS[14378] = Fluid3D([8125,8920,8518,8105],0); -ELEMENTS[14379] = Fluid3D([8125,8920,8105,8156],0); -ELEMENTS[14380] = Fluid3D([8920,8518,8105,9230],0); -ELEMENTS[14381] = Fluid3D([9672,8806,8961,9420],0); -ELEMENTS[14382] = Fluid3D([10571,10330,10812,11647],0); -ELEMENTS[14383] = Fluid3D([8961,8125,8518,8161],0); -ELEMENTS[14384] = Fluid3D([10077,9640,10229,9360],0); -ELEMENTS[14385] = Fluid3D([9640,10229,9360,9673],0); -ELEMENTS[14386] = Fluid3D([10229,9360,9673,9367],0); -ELEMENTS[14387] = Fluid3D([8961,8125,8161,8429],0); -ELEMENTS[14388] = Fluid3D([9420,8429,8806,8961],0); -ELEMENTS[14389] = Fluid3D([10077,9640,9360,9230],0); -ELEMENTS[14390] = Fluid3D([9360,9673,9367,8753],0); -ELEMENTS[14391] = Fluid3D([9367,9360,8753,8464],0); -ELEMENTS[14392] = Fluid3D([9360,8753,8464,9230],0); -ELEMENTS[14393] = Fluid3D([9360,9673,8753,9640],0); -ELEMENTS[14394] = Fluid3D([9367,9360,8464,9395],0); -ELEMENTS[14395] = Fluid3D([9367,9360,9395,10077],0); -ELEMENTS[14396] = Fluid3D([9360,9395,10077,9230],0); -ELEMENTS[14397] = Fluid3D([10571,9653,10330,10548],0); -ELEMENTS[14398] = Fluid3D([10330,10571,10548,11647],0); -ELEMENTS[14399] = Fluid3D([9653,10330,10548,10270],0); -ELEMENTS[14400] = Fluid3D([10571,9653,10548,9998],0); -ELEMENTS[14401] = Fluid3D([8518,8125,8105,7623],0); -ELEMENTS[14402] = Fluid3D([8125,8105,7623,7314],0); -ELEMENTS[14403] = Fluid3D([8518,8125,7623,8161],0); -ELEMENTS[14404] = Fluid3D([8105,8518,7623,7936],0); -ELEMENTS[14405] = Fluid3D([7623,8105,7936,7051],0); -ELEMENTS[14406] = Fluid3D([8105,8518,7936,9230],0); -ELEMENTS[14407] = Fluid3D([10812,10330,10077,11025],0); -ELEMENTS[14408] = Fluid3D([10330,10077,11025,10618],0); -ELEMENTS[14409] = Fluid3D([10077,11025,10618,10969],0); -ELEMENTS[14410] = Fluid3D([11025,10618,10969,11680],0); -ELEMENTS[14411] = Fluid3D([10077,11025,10969,10812],0); -ELEMENTS[14412] = Fluid3D([10812,10330,11025,10983],0); -ELEMENTS[14413] = Fluid3D([10330,11025,10983,10618],0); -ELEMENTS[14414] = Fluid3D([8518,7623,7936,8023],0); -ELEMENTS[14415] = Fluid3D([7623,7936,8023,7275],0); -ELEMENTS[14416] = Fluid3D([7936,8023,7275,8083],0); -ELEMENTS[14417] = Fluid3D([8518,7623,8023,8161],0); -ELEMENTS[14418] = Fluid3D([7936,8023,8083,8657],0); -ELEMENTS[14419] = Fluid3D([7936,8023,8657,8518],0); -ELEMENTS[14420] = Fluid3D([8083,7936,8657,8153],0); -ELEMENTS[14421] = Fluid3D([8083,7936,8153,7362],0); -ELEMENTS[14422] = Fluid3D([8153,8083,7362,8152],0); -ELEMENTS[14423] = Fluid3D([8153,8083,8152,8912],0); -ELEMENTS[14424] = Fluid3D([8153,8083,8912,8657],0); -ELEMENTS[14425] = Fluid3D([8083,8912,8657,8414],0); -ELEMENTS[14426] = Fluid3D([8912,8657,8414,9509],0); -ELEMENTS[14427] = Fluid3D([8912,8657,9509,9684],0); -ELEMENTS[14428] = Fluid3D([8083,8912,8414,8152],0); -ELEMENTS[14429] = Fluid3D([8083,7362,8152,7231],0); -ELEMENTS[14430] = Fluid3D([8657,8083,8414,8023],0); -ELEMENTS[14431] = Fluid3D([8414,8657,8023,9285],0); -ELEMENTS[14432] = Fluid3D([8083,8414,8023,7544],0); -ELEMENTS[14433] = Fluid3D([8414,8023,7544,8024],0); -ELEMENTS[14434] = Fluid3D([8414,8023,8024,9285],0); -ELEMENTS[14435] = Fluid3D([8023,7544,8024,7289],0); -ELEMENTS[14436] = Fluid3D([7544,8414,8024,8517],0); -ELEMENTS[14437] = Fluid3D([8414,8024,8517,9208],0); -ELEMENTS[14438] = Fluid3D([8024,8023,7289,8161],0); -ELEMENTS[14439] = Fluid3D([8023,7544,7289,7275],0); -ELEMENTS[14440] = Fluid3D([8023,8083,7544,7275],0); -ELEMENTS[14441] = Fluid3D([7544,8024,7289,7214],0); -ELEMENTS[14442] = Fluid3D([8024,7289,7214,7496],0); -ELEMENTS[14443] = Fluid3D([8024,7289,7496,8161],0); -ELEMENTS[14444] = Fluid3D([7289,7544,7214,6682],0); -ELEMENTS[14445] = Fluid3D([7289,7544,6682,7275],0); -ELEMENTS[14446] = Fluid3D([7289,7214,7496,6644],0); -ELEMENTS[14447] = Fluid3D([7289,7214,6644,6682],0); -ELEMENTS[14448] = Fluid3D([7214,8024,7496,7853],0); -ELEMENTS[14449] = Fluid3D([7214,8024,7853,8517],0); -ELEMENTS[14450] = Fluid3D([8083,8414,7544,7893],0); -ELEMENTS[14451] = Fluid3D([8414,7544,7893,8517],0); -ELEMENTS[14452] = Fluid3D([7544,7214,6682,7114],0); -ELEMENTS[14453] = Fluid3D([6682,7544,7114,7231],0); -ELEMENTS[14454] = Fluid3D([7214,6682,7114,6521],0); -ELEMENTS[14455] = Fluid3D([6682,7114,6521,6229],0); -ELEMENTS[14456] = Fluid3D([6682,7114,6229,7231],0); -ELEMENTS[14457] = Fluid3D([7544,7214,7114,7813],0); -ELEMENTS[14458] = Fluid3D([7214,7114,7813,7161],0); -ELEMENTS[14459] = Fluid3D([7214,7114,7161,6521],0); -ELEMENTS[14460] = Fluid3D([7544,7214,7813,8517],0); -ELEMENTS[14461] = Fluid3D([7214,6682,6521,6644],0); -ELEMENTS[14462] = Fluid3D([7544,8024,7214,8517],0); -ELEMENTS[14463] = Fluid3D([7496,7289,6644,7063],0); -ELEMENTS[14464] = Fluid3D([7496,7289,7063,8161],0); -ELEMENTS[14465] = Fluid3D([7289,6644,7063,6639],0); -ELEMENTS[14466] = Fluid3D([7289,6644,6639,6682],0); -ELEMENTS[14467] = Fluid3D([7063,7289,6639,7623],0); -ELEMENTS[14468] = Fluid3D([6644,7496,7063,6864],0); -ELEMENTS[14469] = Fluid3D([7496,7063,6864,7634],0); -ELEMENTS[14470] = Fluid3D([6644,7496,6864,6926],0); -ELEMENTS[14471] = Fluid3D([6644,7496,6926,7214],0); -ELEMENTS[14472] = Fluid3D([7063,6644,6864,6256],0); -ELEMENTS[14473] = Fluid3D([7063,6644,6256,6639],0); -ELEMENTS[14474] = Fluid3D([6644,6864,6256,6146],0); -ELEMENTS[14475] = Fluid3D([6256,6644,6146,5922],0); -ELEMENTS[14476] = Fluid3D([6256,6644,5922,6639],0); -ELEMENTS[14477] = Fluid3D([6644,6864,6146,6926],0); -ELEMENTS[14478] = Fluid3D([7496,7063,7634,8161],0); -ELEMENTS[14479] = Fluid3D([6864,6256,6146,6188],0); -ELEMENTS[14480] = Fluid3D([6864,6256,6188,6747],0); -ELEMENTS[14481] = Fluid3D([6256,6146,6188,5657],0); -ELEMENTS[14482] = Fluid3D([6256,6188,6747,5983],0); -ELEMENTS[14483] = Fluid3D([6256,6146,5657,5922],0); -ELEMENTS[14484] = Fluid3D([6256,6188,5983,5657],0); -ELEMENTS[14485] = Fluid3D([6864,6256,6747,7063],0); -ELEMENTS[14486] = Fluid3D([6146,6864,6188,6583],0); -ELEMENTS[14487] = Fluid3D([7063,6864,7634,6747],0); -ELEMENTS[14488] = Fluid3D([7623,7936,7275,7051],0); -ELEMENTS[14489] = Fluid3D([7275,7936,8083,7362],0); -ELEMENTS[14490] = Fluid3D([8024,7496,7853,8379],0); -ELEMENTS[14491] = Fluid3D([8024,7496,8379,8161],0); -ELEMENTS[14492] = Fluid3D([7853,8024,8379,8711],0); -ELEMENTS[14493] = Fluid3D([7496,7853,8379,7418],0); -ELEMENTS[14494] = Fluid3D([8024,8379,8711,9208],0); -ELEMENTS[14495] = Fluid3D([8711,8024,9208,8517],0); -ELEMENTS[14496] = Fluid3D([9208,8711,8517,9239],0); -ELEMENTS[14497] = Fluid3D([9208,8711,9239,9776],0); -ELEMENTS[14498] = Fluid3D([8711,8517,9239,8332],0); -ELEMENTS[14499] = Fluid3D([8711,8517,8332,7853],0); -ELEMENTS[14500] = Fluid3D([9239,8711,8332,9368],0); -ELEMENTS[14501] = Fluid3D([8711,8024,8517,7853],0); -ELEMENTS[14502] = Fluid3D([8332,8711,7853,8608],0); -ELEMENTS[14503] = Fluid3D([8332,8711,8608,9368],0); -ELEMENTS[14504] = Fluid3D([8517,9239,8332,9020],0); -ELEMENTS[14505] = Fluid3D([7853,8332,8608,7889],0); -ELEMENTS[14506] = Fluid3D([8608,7853,7889,8379],0); -ELEMENTS[14507] = Fluid3D([8711,7853,8608,8379],0); -ELEMENTS[14508] = Fluid3D([8379,8711,9208,9776],0); -ELEMENTS[14509] = Fluid3D([8023,7623,7275,7289],0); -ELEMENTS[14510] = Fluid3D([9653,8920,9230,8518],0); -ELEMENTS[14511] = Fluid3D([10229,10077,9360,9367],0); -ELEMENTS[14512] = Fluid3D([8429,8897,8806,7616],0); -ELEMENTS[14513] = Fluid3D([8806,8897,9622,8468],0); -ELEMENTS[14514] = Fluid3D([10812,10077,10229,10969],0); -ELEMENTS[14515] = Fluid3D([6864,7496,7634,7418],0); -ELEMENTS[14516] = Fluid3D([8518,8961,8161,9285],0); -ELEMENTS[14517] = Fluid3D([14143,13857,13460,14557],0); -ELEMENTS[14518] = Fluid3D([13296,14252,13550,13564],0); -ELEMENTS[14519] = Fluid3D([11283,11663,11942,10815],0); -ELEMENTS[14520] = Fluid3D([13703,13164,13503,13839],0); -ELEMENTS[14521] = Fluid3D([12264,12818,12528,11839],0); -ELEMENTS[14522] = Fluid3D([13703,12978,13164,13907],0); -ELEMENTS[14523] = Fluid3D([13300,12931,12369,13282],0); -ELEMENTS[14524] = Fluid3D([12848,12021,12155,12037],0); -ELEMENTS[14525] = Fluid3D([12021,12155,12037,11245],0); -ELEMENTS[14526] = Fluid3D([12155,12037,11245,11621],0); -ELEMENTS[14527] = Fluid3D([12037,11245,11621,10696],0); -ELEMENTS[14528] = Fluid3D([12155,12848,12037,12803],0); -ELEMENTS[14529] = Fluid3D([12848,12021,12037,12462],0); -ELEMENTS[14530] = Fluid3D([12037,12021,11245,11322],0); -ELEMENTS[14531] = Fluid3D([11245,12037,11322,10696],0); -ELEMENTS[14532] = Fluid3D([12021,11245,11322,10550],0); -ELEMENTS[14533] = Fluid3D([11245,12155,11621,11331],0); -ELEMENTS[14534] = Fluid3D([11621,11245,11331,10599],0); -ELEMENTS[14535] = Fluid3D([11245,12155,11331,11701],0); -ELEMENTS[14536] = Fluid3D([11245,11331,10599,10503],0); -ELEMENTS[14537] = Fluid3D([11245,11331,10503,11701],0); -ELEMENTS[14538] = Fluid3D([12155,11621,11331,12157],0); -ELEMENTS[14539] = Fluid3D([10599,11245,10503,10550],0); -ELEMENTS[14540] = Fluid3D([11245,10503,10550,11701],0); -ELEMENTS[14541] = Fluid3D([11621,11331,12157,11246],0); -ELEMENTS[14542] = Fluid3D([11621,11331,11246,10599],0); -ELEMENTS[14543] = Fluid3D([11331,12157,11246,11315],0); -ELEMENTS[14544] = Fluid3D([11331,10599,10503,10498],0); -ELEMENTS[14545] = Fluid3D([12155,11621,12157,12803],0); -ELEMENTS[14546] = Fluid3D([12157,11621,11246,12079],0); -ELEMENTS[14547] = Fluid3D([12157,11621,12079,12803],0); -ELEMENTS[14548] = Fluid3D([11621,11246,12079,11225],0); -ELEMENTS[14549] = Fluid3D([12079,11621,11225,12234],0); -ELEMENTS[14550] = Fluid3D([11621,11246,11225,10599],0); -ELEMENTS[14551] = Fluid3D([11225,11621,10599,10696],0); -ELEMENTS[14552] = Fluid3D([11246,11225,10599,10569],0); -ELEMENTS[14553] = Fluid3D([11246,12079,11225,11366],0); -ELEMENTS[14554] = Fluid3D([12021,12155,11245,11701],0); -ELEMENTS[14555] = Fluid3D([11621,11245,10599,10696],0); -ELEMENTS[14556] = Fluid3D([11331,12155,12157,12153],0); -ELEMENTS[14557] = Fluid3D([11331,12155,12153,11701],0); -ELEMENTS[14558] = Fluid3D([12155,12157,12153,13079],0); -ELEMENTS[14559] = Fluid3D([12157,11331,12153,11839],0); -ELEMENTS[14560] = Fluid3D([12155,12037,11621,12803],0); -ELEMENTS[14561] = Fluid3D([13488,13460,13043,12614],0); -ELEMENTS[14562] = Fluid3D([13539,13814,14309,14125],0); -ELEMENTS[14563] = Fluid3D([13539,13814,14125,13282],0); -ELEMENTS[14564] = Fluid3D([14309,13539,14125,14343],0); -ELEMENTS[14565] = Fluid3D([13814,14309,14125,14814],0); -ELEMENTS[14566] = Fluid3D([13839,13164,13907,13703],0); -ELEMENTS[14567] = Fluid3D([13814,13296,13564,14252],0); -ELEMENTS[14568] = Fluid3D([13839,13907,14252,14578],0); -ELEMENTS[14569] = Fluid3D([5689,5893,6306,6021],0); -ELEMENTS[14570] = Fluid3D([12214,11366,11807,12341],0); -ELEMENTS[14571] = Fluid3D([11807,12214,12341,12900],0); -ELEMENTS[14572] = Fluid3D([12214,12341,12900,12921],0); -ELEMENTS[14573] = Fluid3D([11366,11807,12341,12079],0); -ELEMENTS[14574] = Fluid3D([12214,11366,12341,12181],0); -ELEMENTS[14575] = Fluid3D([12341,12214,12181,12921],0); -ELEMENTS[14576] = Fluid3D([12181,12341,12921,12079],0); -ELEMENTS[14577] = Fluid3D([12921,12181,12079,12157],0); -ELEMENTS[14578] = Fluid3D([12181,12341,12079,11366],0); -ELEMENTS[14579] = Fluid3D([12214,11366,12181,11434],0); -ELEMENTS[14580] = Fluid3D([11926,12635,12846,12310],0); -ELEMENTS[14581] = Fluid3D([11926,12635,12310,11796],0); -ELEMENTS[14582] = Fluid3D([12846,11926,12310,11739],0); -ELEMENTS[14583] = Fluid3D([12635,12846,12310,13625],0); -ELEMENTS[14584] = Fluid3D([12018,12640,11666,11954],0); -ELEMENTS[14585] = Fluid3D([7230,8058,7827,7532],0); -ELEMENTS[14586] = Fluid3D([7827,7230,7532,7023],0); -ELEMENTS[14587] = Fluid3D([7230,8058,7532,7367],0); -ELEMENTS[14588] = Fluid3D([7532,7230,7367,6710],0); -ELEMENTS[14589] = Fluid3D([7532,7230,6710,7023],0); -ELEMENTS[14590] = Fluid3D([7532,7827,7023,7704],0); -ELEMENTS[14591] = Fluid3D([7532,7827,7704,8542],0); -ELEMENTS[14592] = Fluid3D([7704,7532,8542,7900],0); -ELEMENTS[14593] = Fluid3D([7532,7827,8542,8058],0); -ELEMENTS[14594] = Fluid3D([7704,7532,7900,7053],0); -ELEMENTS[14595] = Fluid3D([7704,7532,7053,7023],0); -ELEMENTS[14596] = Fluid3D([7532,7900,7053,7341],0); -ELEMENTS[14597] = Fluid3D([7532,7900,7341,8245],0); -ELEMENTS[14598] = Fluid3D([7341,7532,8245,7367],0); -ELEMENTS[14599] = Fluid3D([7053,7532,7341,6710],0); -ELEMENTS[14600] = Fluid3D([7532,7900,8245,8542],0); -ELEMENTS[14601] = Fluid3D([7900,7053,7341,7304],0); -ELEMENTS[14602] = Fluid3D([7053,7341,7304,6456],0); -ELEMENTS[14603] = Fluid3D([7304,7053,6456,6647],0); -ELEMENTS[14604] = Fluid3D([7304,7053,6647,7487],0); -ELEMENTS[14605] = Fluid3D([7304,7053,7487,7900],0); -ELEMENTS[14606] = Fluid3D([6647,7304,7487,7241],0); -ELEMENTS[14607] = Fluid3D([7304,7487,7241,8044],0); -ELEMENTS[14608] = Fluid3D([6647,7304,7241,6698],0); -ELEMENTS[14609] = Fluid3D([6647,7304,6698,6456],0); -ELEMENTS[14610] = Fluid3D([7241,6647,6698,6406],0); -ELEMENTS[14611] = Fluid3D([6698,7241,6406,6906],0); -ELEMENTS[14612] = Fluid3D([6698,7241,6906,7485],0); -ELEMENTS[14613] = Fluid3D([7241,6647,6406,6878],0); -ELEMENTS[14614] = Fluid3D([7241,6647,6878,7487],0); -ELEMENTS[14615] = Fluid3D([6698,7241,7485,7304],0); -ELEMENTS[14616] = Fluid3D([7304,7487,8044,7900],0); -ELEMENTS[14617] = Fluid3D([7053,7341,6456,6710],0); -ELEMENTS[14618] = Fluid3D([6906,6698,7485,6807],0); -ELEMENTS[14619] = Fluid3D([6906,6698,6807,6150],0); -ELEMENTS[14620] = Fluid3D([6698,7485,6807,7117],0); -ELEMENTS[14621] = Fluid3D([7485,6906,6807,7452],0); -ELEMENTS[14622] = Fluid3D([6807,7485,7452,7584],0); -ELEMENTS[14623] = Fluid3D([6698,7485,7117,7304],0); -ELEMENTS[14624] = Fluid3D([6807,7485,7584,7117],0); -ELEMENTS[14625] = Fluid3D([7485,6906,7452,7749],0); -ELEMENTS[14626] = Fluid3D([6906,7452,7749,7271],0); -ELEMENTS[14627] = Fluid3D([7452,7749,7271,8095],0); -ELEMENTS[14628] = Fluid3D([7485,6906,7749,7241],0); -ELEMENTS[14629] = Fluid3D([7452,7749,8095,8271],0); -ELEMENTS[14630] = Fluid3D([7452,7749,8271,7485],0); -ELEMENTS[14631] = Fluid3D([8095,7452,8271,8122],0); -ELEMENTS[14632] = Fluid3D([8271,8095,8122,8926],0); -ELEMENTS[14633] = Fluid3D([8271,8095,8926,8743],0); -ELEMENTS[14634] = Fluid3D([8271,8095,8743,7749],0); -ELEMENTS[14635] = Fluid3D([8095,7452,8122,7471],0); -ELEMENTS[14636] = Fluid3D([8122,8095,7471,8389],0); -ELEMENTS[14637] = Fluid3D([8122,8095,8389,8926],0); -ELEMENTS[14638] = Fluid3D([8095,7452,7471,7271],0); -ELEMENTS[14639] = Fluid3D([6906,7452,7271,6653],0); -ELEMENTS[14640] = Fluid3D([6906,7452,6653,6807],0); -ELEMENTS[14641] = Fluid3D([7452,7271,6653,7471],0); -ELEMENTS[14642] = Fluid3D([6807,6906,6150,6653],0); -ELEMENTS[14643] = Fluid3D([6698,6807,6150,6213],0); -ELEMENTS[14644] = Fluid3D([6698,6807,6213,7117],0); -ELEMENTS[14645] = Fluid3D([6150,6698,6213,5969],0); -ELEMENTS[14646] = Fluid3D([6150,6698,5969,6406],0); -ELEMENTS[14647] = Fluid3D([6698,6213,5969,6456],0); -ELEMENTS[14648] = Fluid3D([6807,6150,6213,6094],0); -ELEMENTS[14649] = Fluid3D([6213,6807,6094,6538],0); -ELEMENTS[14650] = Fluid3D([6807,6094,6538,6790],0); -ELEMENTS[14651] = Fluid3D([6807,6094,6790,6653],0); -ELEMENTS[14652] = Fluid3D([6807,6150,6094,6653],0); -ELEMENTS[14653] = Fluid3D([6213,6807,6538,7117],0); -ELEMENTS[14654] = Fluid3D([6150,6213,6094,5595],0); -ELEMENTS[14655] = Fluid3D([6213,6094,5595,5701],0); -ELEMENTS[14656] = Fluid3D([6094,5595,5701,5458],0); -ELEMENTS[14657] = Fluid3D([6094,5595,5458,5674],0); -ELEMENTS[14658] = Fluid3D([6094,5595,5674,6150],0); -ELEMENTS[14659] = Fluid3D([6150,6213,5595,5969],0); -ELEMENTS[14660] = Fluid3D([6213,6094,5701,6538],0); -ELEMENTS[14661] = Fluid3D([6094,6538,6790,6231],0); -ELEMENTS[14662] = Fluid3D([6094,6538,6231,5701],0); -ELEMENTS[14663] = Fluid3D([6790,6094,6231,6134],0); -ELEMENTS[14664] = Fluid3D([6538,6790,6231,6941],0); -ELEMENTS[14665] = Fluid3D([6094,6231,6134,5458],0); -ELEMENTS[14666] = Fluid3D([6790,6231,6941,6678],0); -ELEMENTS[14667] = Fluid3D([6790,6231,6678,6134],0); -ELEMENTS[14668] = Fluid3D([6231,6941,6678,6431],0); -ELEMENTS[14669] = Fluid3D([6941,6678,6431,7222],0); -ELEMENTS[14670] = Fluid3D([6941,6678,7222,7558],0); -ELEMENTS[14671] = Fluid3D([6941,6678,7558,6790],0); -ELEMENTS[14672] = Fluid3D([6231,6941,6431,6668],0); -ELEMENTS[14673] = Fluid3D([6790,6094,6134,6653],0); -ELEMENTS[14674] = Fluid3D([6538,6790,6941,7584],0); -ELEMENTS[14675] = Fluid3D([7749,7271,8095,7980],0); -ELEMENTS[14676] = Fluid3D([7271,8095,7980,7786],0); -ELEMENTS[14677] = Fluid3D([8095,7749,7980,8743],0); -ELEMENTS[14678] = Fluid3D([7749,7271,7980,7253],0); -ELEMENTS[14679] = Fluid3D([7271,7980,7253,7244],0); -ELEMENTS[14680] = Fluid3D([7271,7980,7244,7786],0); -ELEMENTS[14681] = Fluid3D([7271,8095,7786,7471],0); -ELEMENTS[14682] = Fluid3D([7749,7271,7253,6906],0); -ELEMENTS[14683] = Fluid3D([7980,7749,7253,8067],0); -ELEMENTS[14684] = Fluid3D([7980,7749,8067,8743],0); -ELEMENTS[14685] = Fluid3D([7253,7980,8067,7761],0); -ELEMENTS[14686] = Fluid3D([7253,7980,7761,7244],0); -ELEMENTS[14687] = Fluid3D([8067,7253,7761,7421],0); -ELEMENTS[14688] = Fluid3D([7749,7253,8067,7241],0); -ELEMENTS[14689] = Fluid3D([7253,7761,7421,6911],0); -ELEMENTS[14690] = Fluid3D([7761,7421,6911,7500],0); -ELEMENTS[14691] = Fluid3D([7761,7421,7500,8211],0); -ELEMENTS[14692] = Fluid3D([7761,7421,8211,8067],0); -ELEMENTS[14693] = Fluid3D([7253,7761,6911,7244],0); -ELEMENTS[14694] = Fluid3D([7980,8067,7761,8647],0); -ELEMENTS[14695] = Fluid3D([8067,7761,8647,8211],0); -ELEMENTS[14696] = Fluid3D([7980,8067,8647,8743],0); -ELEMENTS[14697] = Fluid3D([8067,7253,7421,7241],0); -ELEMENTS[14698] = Fluid3D([7421,6911,7500,6794],0); -ELEMENTS[14699] = Fluid3D([6911,7500,6794,6723],0); -ELEMENTS[14700] = Fluid3D([7421,6911,6794,6588],0); -ELEMENTS[14701] = Fluid3D([7500,7421,6794,7651],0); -ELEMENTS[14702] = Fluid3D([7500,7421,7651,8211],0); -ELEMENTS[14703] = Fluid3D([7500,6794,6723,7290],0); -ELEMENTS[14704] = Fluid3D([6723,7500,7290,7461],0); -ELEMENTS[14705] = Fluid3D([7500,7290,7461,8073],0); -ELEMENTS[14706] = Fluid3D([7290,6723,7461,7171],0); -ELEMENTS[14707] = Fluid3D([7500,6794,7290,7651],0); -ELEMENTS[14708] = Fluid3D([7290,7500,7651,8269],0); -ELEMENTS[14709] = Fluid3D([7290,7500,8269,8073],0); -ELEMENTS[14710] = Fluid3D([7290,7461,8073,7171],0); -ELEMENTS[14711] = Fluid3D([8269,7290,8073,7810],0); -ELEMENTS[14712] = Fluid3D([6723,7500,7461,6911],0); -ELEMENTS[14713] = Fluid3D([6794,6723,7290,6792],0); -ELEMENTS[14714] = Fluid3D([7500,7651,8269,8211],0); -ELEMENTS[14715] = Fluid3D([8269,7500,8211,8676],0); -ELEMENTS[14716] = Fluid3D([8211,8269,8676,9089],0); -ELEMENTS[14717] = Fluid3D([8676,8211,9089,9027],0); -ELEMENTS[14718] = Fluid3D([8676,8211,9027,8647],0); -ELEMENTS[14719] = Fluid3D([8211,9027,8647,8067],0); -ELEMENTS[14720] = Fluid3D([9027,8676,8647,9263],0); -ELEMENTS[14721] = Fluid3D([8647,9027,9263,9591],0); -ELEMENTS[14722] = Fluid3D([8647,9027,9591,9008],0); -ELEMENTS[14723] = Fluid3D([8647,9027,9008,8067],0); -ELEMENTS[14724] = Fluid3D([9027,9263,9591,9615],0); -ELEMENTS[14725] = Fluid3D([9027,9263,9615,8676],0); -ELEMENTS[14726] = Fluid3D([9615,9027,8676,9089],0); -ELEMENTS[14727] = Fluid3D([9027,9591,9008,9797],0); -ELEMENTS[14728] = Fluid3D([9615,9027,9089,9797],0); -ELEMENTS[14729] = Fluid3D([9615,9027,9797,9591],0); -ELEMENTS[14730] = Fluid3D([9008,9027,9797,8960],0); -ELEMENTS[14731] = Fluid3D([9008,9027,8960,8067],0); -ELEMENTS[14732] = Fluid3D([9591,8647,9008,8743],0); -ELEMENTS[14733] = Fluid3D([9027,9797,8960,9089],0); -ELEMENTS[14734] = Fluid3D([8960,9027,9089,8211],0); -ELEMENTS[14735] = Fluid3D([9008,8647,8067,8743],0); -ELEMENTS[14736] = Fluid3D([9263,9615,8676,9356],0); -ELEMENTS[14737] = Fluid3D([9263,9615,9356,10170],0); -ELEMENTS[14738] = Fluid3D([9263,9615,10170,9591],0); -ELEMENTS[14739] = Fluid3D([9356,9263,10170,9546],0); -ELEMENTS[14740] = Fluid3D([9263,10170,9546,9963],0); -ELEMENTS[14741] = Fluid3D([9356,9263,9546,8621],0); -ELEMENTS[14742] = Fluid3D([9356,9263,8621,8676],0); -ELEMENTS[14743] = Fluid3D([9263,9546,8621,9102],0); -ELEMENTS[14744] = Fluid3D([9797,9008,8960,9469],0); -ELEMENTS[14745] = Fluid3D([9008,8960,9469,8502],0); -ELEMENTS[14746] = Fluid3D([9008,8960,8502,8067],0); -ELEMENTS[14747] = Fluid3D([9591,9008,9797,9919],0); -ELEMENTS[14748] = Fluid3D([9797,9591,9919,11077],0); -ELEMENTS[14749] = Fluid3D([8960,9797,9469,9816],0); -ELEMENTS[14750] = Fluid3D([9469,8960,9816,9039],0); -ELEMENTS[14751] = Fluid3D([9469,8960,9039,8502],0); -ELEMENTS[14752] = Fluid3D([8960,9797,9816,9089],0); -ELEMENTS[14753] = Fluid3D([9816,8960,9089,8907],0); -ELEMENTS[14754] = Fluid3D([8960,9089,8907,8155],0); -ELEMENTS[14755] = Fluid3D([8960,9089,8155,8211],0); -ELEMENTS[14756] = Fluid3D([9089,8155,8211,8269],0); -ELEMENTS[14757] = Fluid3D([8155,8960,8211,8067],0); -ELEMENTS[14758] = Fluid3D([8907,8960,8155,8321],0); -ELEMENTS[14759] = Fluid3D([8907,8960,8321,9039],0); -ELEMENTS[14760] = Fluid3D([8321,8907,9039,8604],0); -ELEMENTS[14761] = Fluid3D([9039,8321,8604,8491],0); -ELEMENTS[14762] = Fluid3D([9039,8321,8491,8502],0); -ELEMENTS[14763] = Fluid3D([9039,8321,8502,8960],0); -ELEMENTS[14764] = Fluid3D([8907,9039,8604,9465],0); -ELEMENTS[14765] = Fluid3D([8321,8502,8960,8067],0); -ELEMENTS[14766] = Fluid3D([8907,9039,9465,9816],0); -ELEMENTS[14767] = Fluid3D([8907,8960,9039,9816],0); -ELEMENTS[14768] = Fluid3D([8604,9039,8491,9036],0); -ELEMENTS[14769] = Fluid3D([9039,8604,9465,9036],0); -ELEMENTS[14770] = Fluid3D([8604,9465,9036,9508],0); -ELEMENTS[14771] = Fluid3D([9465,9036,9508,10135],0); -ELEMENTS[14772] = Fluid3D([9508,9465,10135,10352],0); -ELEMENTS[14773] = Fluid3D([9508,9465,10352,9787],0); -ELEMENTS[14774] = Fluid3D([8321,8491,8502,7487],0); -ELEMENTS[14775] = Fluid3D([8960,8155,8321,8067],0); -ELEMENTS[14776] = Fluid3D([8321,8604,8491,7487],0); -ELEMENTS[14777] = Fluid3D([8604,8907,9465,9044],0); -ELEMENTS[14778] = Fluid3D([8907,9465,9044,9908],0); -ELEMENTS[14779] = Fluid3D([8321,8907,8604,7991],0); -ELEMENTS[14780] = Fluid3D([8604,8321,7991,7487],0); -ELEMENTS[14781] = Fluid3D([8604,8907,9044,7991],0); -ELEMENTS[14782] = Fluid3D([9089,8907,8155,8446],0); -ELEMENTS[14783] = Fluid3D([8155,9089,8446,8269],0); -ELEMENTS[14784] = Fluid3D([10135,9508,10352,10446],0); -ELEMENTS[14785] = Fluid3D([9508,10352,10446,9787],0); -ELEMENTS[14786] = Fluid3D([8155,8907,8321,7991],0); -ELEMENTS[14787] = Fluid3D([8321,8155,7991,7505],0); -ELEMENTS[14788] = Fluid3D([8155,7991,7505,7651],0); -ELEMENTS[14789] = Fluid3D([8155,8907,7991,8446],0); -ELEMENTS[14790] = Fluid3D([7505,8155,7651,7421],0); -ELEMENTS[14791] = Fluid3D([7651,7505,7421,6794],0); -ELEMENTS[14792] = Fluid3D([7505,8155,7421,8067],0); -ELEMENTS[14793] = Fluid3D([8155,7991,7651,8446],0); -ELEMENTS[14794] = Fluid3D([7991,8321,7505,7487],0); -ELEMENTS[14795] = Fluid3D([8321,8155,7505,8067],0); -ELEMENTS[14796] = Fluid3D([9469,9008,8502,9043],0); -ELEMENTS[14797] = Fluid3D([9469,9008,9043,9919],0); -ELEMENTS[14798] = Fluid3D([9008,8502,9043,8743],0); -ELEMENTS[14799] = Fluid3D([9043,9008,8743,9919],0); -ELEMENTS[14800] = Fluid3D([9546,9356,8621,9130],0); -ELEMENTS[14801] = Fluid3D([9615,9356,10170,10230],0); -ELEMENTS[14802] = Fluid3D([10170,9615,10230,10768],0); -ELEMENTS[14803] = Fluid3D([9356,10170,10230,10089],0); -ELEMENTS[14804] = Fluid3D([10230,10170,10768,11229],0); -ELEMENTS[14805] = Fluid3D([9008,9797,9919,9469],0); -ELEMENTS[14806] = Fluid3D([9465,8604,9044,9508],0); -ELEMENTS[14807] = Fluid3D([9044,9465,9508,9787],0); -ELEMENTS[14808] = Fluid3D([9465,9036,10135,9722],0); -ELEMENTS[14809] = Fluid3D([9465,9036,9722,9039],0); -ELEMENTS[14810] = Fluid3D([9722,9465,9039,9816],0); -ELEMENTS[14811] = Fluid3D([8269,7500,8676,8073],0); -ELEMENTS[14812] = Fluid3D([9089,8907,8446,9661],0); -ELEMENTS[14813] = Fluid3D([9263,8647,9591,9102],0); -ELEMENTS[14814] = Fluid3D([9591,9008,9919,8743],0); -ELEMENTS[14815] = Fluid3D([7421,6911,6588,7253],0); -ELEMENTS[14816] = Fluid3D([6794,6911,6723,6157],0); -ELEMENTS[14817] = Fluid3D([6911,6723,6157,6386],0); -ELEMENTS[14818] = Fluid3D([6794,6911,6157,6588],0); -ELEMENTS[14819] = Fluid3D([6723,6794,6157,6329],0); -ELEMENTS[14820] = Fluid3D([6723,6157,6386,5787],0); -ELEMENTS[14821] = Fluid3D([6723,6157,5787,6329],0); -ELEMENTS[14822] = Fluid3D([6157,6386,5787,5713],0); -ELEMENTS[14823] = Fluid3D([6386,5787,5713,5897],0); -ELEMENTS[14824] = Fluid3D([6386,5787,5897,6667],0); -ELEMENTS[14825] = Fluid3D([6157,6386,5713,6180],0); -ELEMENTS[14826] = Fluid3D([6157,6386,6180,6911],0); -ELEMENTS[14827] = Fluid3D([6386,5787,6667,6723],0); -ELEMENTS[14828] = Fluid3D([6911,6723,6386,7461],0); -ELEMENTS[14829] = Fluid3D([6794,6157,6329,6219],0); -ELEMENTS[14830] = Fluid3D([6329,6794,6219,6812],0); -ELEMENTS[14831] = Fluid3D([6329,6794,6812,7308],0); -ELEMENTS[14832] = Fluid3D([6794,6219,6812,6878],0); -ELEMENTS[14833] = Fluid3D([6219,6329,6812,5851],0); -ELEMENTS[14834] = Fluid3D([6794,6157,6219,6588],0); -ELEMENTS[14835] = Fluid3D([6219,6794,6588,6878],0); -ELEMENTS[14836] = Fluid3D([6588,6219,6878,6406],0); -ELEMENTS[14837] = Fluid3D([6878,6588,6406,7241],0); -ELEMENTS[14838] = Fluid3D([6157,6219,6588,5880],0); -ELEMENTS[14839] = Fluid3D([6219,6588,5880,6406],0); -ELEMENTS[14840] = Fluid3D([6588,5880,6406,6180],0); -ELEMENTS[14841] = Fluid3D([8095,7980,7786,8665],0); -ELEMENTS[14842] = Fluid3D([8095,7980,8665,8743],0); -ELEMENTS[14843] = Fluid3D([7786,8095,8665,8389],0); -ELEMENTS[14844] = Fluid3D([7980,7786,8665,8193],0); -ELEMENTS[14845] = Fluid3D([8665,7980,8193,8647],0); -ELEMENTS[14846] = Fluid3D([7786,8665,8193,8808],0); -ELEMENTS[14847] = Fluid3D([7786,8665,8808,8389],0); -ELEMENTS[14848] = Fluid3D([8665,8193,8808,9102],0); -ELEMENTS[14849] = Fluid3D([7980,7786,8193,7244],0); -ELEMENTS[14850] = Fluid3D([7341,7900,7304,7852],0); -ELEMENTS[14851] = Fluid3D([7304,7341,7852,7117],0); -ELEMENTS[14852] = Fluid3D([7341,7900,7852,8245],0); -ELEMENTS[14853] = Fluid3D([7900,7304,7852,8044],0); -ELEMENTS[14854] = Fluid3D([6678,6231,6431,5957],0); -ELEMENTS[14855] = Fluid3D([6231,6431,5957,5686],0); -ELEMENTS[14856] = Fluid3D([5957,6231,5686,5458],0); -ELEMENTS[14857] = Fluid3D([6431,6678,5957,6505],0); -ELEMENTS[14858] = Fluid3D([6678,5957,6505,6331],0); -ELEMENTS[14859] = Fluid3D([5957,6505,6331,6121],0); -ELEMENTS[14860] = Fluid3D([6505,6331,6121,6680],0); -ELEMENTS[14861] = Fluid3D([5957,6505,6121,6245],0); -ELEMENTS[14862] = Fluid3D([6505,6121,6245,6830],0); -ELEMENTS[14863] = Fluid3D([6505,6121,6830,6680],0); -ELEMENTS[14864] = Fluid3D([6678,6231,5957,6134],0); -ELEMENTS[14865] = Fluid3D([6431,6678,6505,7222],0); -ELEMENTS[14866] = Fluid3D([6678,5957,6331,6134],0); -ELEMENTS[14867] = Fluid3D([6231,6431,5686,6141],0); -ELEMENTS[14868] = Fluid3D([5686,6231,6141,5701],0); -ELEMENTS[14869] = Fluid3D([6231,6431,6141,6668],0); -ELEMENTS[14870] = Fluid3D([6431,5686,6141,5767],0); -ELEMENTS[14871] = Fluid3D([6505,6678,6331,7127],0); -ELEMENTS[14872] = Fluid3D([6505,6678,7127,7222],0); -ELEMENTS[14873] = Fluid3D([6331,6505,7127,6680],0); -ELEMENTS[14874] = Fluid3D([6678,6331,7127,6924],0); -ELEMENTS[14875] = Fluid3D([6678,6331,6924,6134],0); -ELEMENTS[14876] = Fluid3D([7127,6678,6924,7558],0); -ELEMENTS[14877] = Fluid3D([6331,7127,6924,6914],0); -ELEMENTS[14878] = Fluid3D([6924,6331,6914,6312],0); -ELEMENTS[14879] = Fluid3D([6914,6924,6312,7042],0); -ELEMENTS[14880] = Fluid3D([6331,7127,6914,6680],0); -ELEMENTS[14881] = Fluid3D([6914,6924,7042,7678],0); -ELEMENTS[14882] = Fluid3D([6914,6924,7678,7127],0); -ELEMENTS[14883] = Fluid3D([6924,7042,7678,7471],0); -ELEMENTS[14884] = Fluid3D([6924,6331,6312,6134],0); -ELEMENTS[14885] = Fluid3D([6431,5957,5686,5629],0); -ELEMENTS[14886] = Fluid3D([5957,5686,5629,5079],0); -ELEMENTS[14887] = Fluid3D([6331,6914,6312,6151],0); -ELEMENTS[14888] = Fluid3D([6914,6312,6151,6564],0); -ELEMENTS[14889] = Fluid3D([6331,6914,6151,6680],0); -ELEMENTS[14890] = Fluid3D([6312,6331,6151,5727],0); -ELEMENTS[14891] = Fluid3D([6331,6151,5727,5527],0); -ELEMENTS[14892] = Fluid3D([6151,6914,6564,6780],0); -ELEMENTS[14893] = Fluid3D([6151,6914,6780,6680],0); -ELEMENTS[14894] = Fluid3D([6914,6564,6780,7427],0); -ELEMENTS[14895] = Fluid3D([6914,6564,7427,7042],0); -ELEMENTS[14896] = Fluid3D([6564,6780,7427,6707],0); -ELEMENTS[14897] = Fluid3D([6780,7427,6707,7233],0); -ELEMENTS[14898] = Fluid3D([6780,7427,7233,7537],0); -ELEMENTS[14899] = Fluid3D([6780,7427,7537,6914],0); -ELEMENTS[14900] = Fluid3D([6564,6780,6707,5930],0); -ELEMENTS[14901] = Fluid3D([6312,6331,5727,6134],0); -ELEMENTS[14902] = Fluid3D([6914,6312,6564,7042],0); -ELEMENTS[14903] = Fluid3D([6151,6312,5727,5775],0); -ELEMENTS[14904] = Fluid3D([6151,6312,5775,6564],0); -ELEMENTS[14905] = Fluid3D([6312,5727,5775,5750],0); -ELEMENTS[14906] = Fluid3D([6312,5727,5750,6134],0); -ELEMENTS[14907] = Fluid3D([5727,6151,5775,5424],0); -ELEMENTS[14908] = Fluid3D([5727,5775,5750,5227],0); -ELEMENTS[14909] = Fluid3D([5750,5727,5227,5335],0); -ELEMENTS[14910] = Fluid3D([5727,5227,5335,4980],0); -ELEMENTS[14911] = Fluid3D([5727,5775,5227,5424],0); -ELEMENTS[14912] = Fluid3D([5750,5727,5335,6134],0); -ELEMENTS[14913] = Fluid3D([5775,5750,5227,5459],0); -ELEMENTS[14914] = Fluid3D([5750,5227,5459,5152],0); -ELEMENTS[14915] = Fluid3D([5227,5459,5152,4849],0); -ELEMENTS[14916] = Fluid3D([5227,5459,4849,4903],0); -ELEMENTS[14917] = Fluid3D([4849,5227,4903,4469],0); -ELEMENTS[14918] = Fluid3D([5775,5750,5459,6072],0); -ELEMENTS[14919] = Fluid3D([5750,5459,6072,5757],0); -ELEMENTS[14920] = Fluid3D([5750,5459,5757,5152],0); -ELEMENTS[14921] = Fluid3D([5775,5750,6072,6312],0); -ELEMENTS[14922] = Fluid3D([5750,5227,5152,5335],0); -ELEMENTS[14923] = Fluid3D([5227,5775,5459,4903],0); -ELEMENTS[14924] = Fluid3D([6924,6312,7042,6645],0); -ELEMENTS[14925] = Fluid3D([6924,6312,6645,6134],0); -ELEMENTS[14926] = Fluid3D([6312,7042,6645,6072],0); -ELEMENTS[14927] = Fluid3D([7042,6924,6645,7471],0); -ELEMENTS[14928] = Fluid3D([5957,6431,6505,6245],0); -ELEMENTS[14929] = Fluid3D([6906,6698,6150,6406],0); -ELEMENTS[14930] = Fluid3D([6647,6698,6406,5969],0); -ELEMENTS[14931] = Fluid3D([7452,6807,7584,6790],0); -ELEMENTS[14932] = Fluid3D([7230,8058,7367,7627],0); -ELEMENTS[14933] = Fluid3D([8542,7704,7900,8491],0); -ELEMENTS[14934] = Fluid3D([7241,7304,8044,7485],0); -ELEMENTS[14935] = Fluid3D([8095,8926,8743,8665],0); -ELEMENTS[14936] = Fluid3D([7367,7532,6710,7341],0); -ELEMENTS[14937] = Fluid3D([6564,6151,6780,5930],0); -ELEMENTS[14938] = Fluid3D([7900,7704,7053,7487],0); -ELEMENTS[14939] = Fluid3D([7485,7452,7584,8271],0); -ELEMENTS[14940] = Fluid3D([7053,6456,6647,6234],0); -ELEMENTS[14941] = Fluid3D([6456,6647,6234,5969],0); -ELEMENTS[14942] = Fluid3D([7053,6456,6234,6710],0); -ELEMENTS[14943] = Fluid3D([6647,7053,6234,6741],0); -ELEMENTS[14944] = Fluid3D([6647,7053,6741,7487],0); -ELEMENTS[14945] = Fluid3D([6234,6647,6741,6068],0); -ELEMENTS[14946] = Fluid3D([7053,6234,6741,7023],0); -ELEMENTS[14947] = Fluid3D([6741,6234,6068,6051],0); -ELEMENTS[14948] = Fluid3D([6234,6068,6051,5586],0); -ELEMENTS[14949] = Fluid3D([6068,6051,5586,5589],0); -ELEMENTS[14950] = Fluid3D([6051,5586,5589,5413],0); -ELEMENTS[14951] = Fluid3D([6051,5586,5413,5789],0); -ELEMENTS[14952] = Fluid3D([6051,5586,5789,6234],0); -ELEMENTS[14953] = Fluid3D([5586,5413,5789,5038],0); -ELEMENTS[14954] = Fluid3D([5586,5413,5038,5004],0); -ELEMENTS[14955] = Fluid3D([5586,5413,5004,5589],0); -ELEMENTS[14956] = Fluid3D([5413,5789,5038,5328],0); -ELEMENTS[14957] = Fluid3D([5413,5789,5328,5871],0); -ELEMENTS[14958] = Fluid3D([5789,5328,5871,5908],0); -ELEMENTS[14959] = Fluid3D([5789,5038,5328,5417],0); -ELEMENTS[14960] = Fluid3D([5789,5038,5417,5489],0); -ELEMENTS[14961] = Fluid3D([5789,5038,5489,5586],0); -ELEMENTS[14962] = Fluid3D([6234,6647,6068,5969],0); -ELEMENTS[14963] = Fluid3D([5413,5789,5871,6051],0); -ELEMENTS[14964] = Fluid3D([5789,5328,5908,5417],0); -ELEMENTS[14965] = Fluid3D([5871,5789,5908,6416],0); -ELEMENTS[14966] = Fluid3D([5871,5789,6416,6051],0); -ELEMENTS[14967] = Fluid3D([5789,5908,6416,6193],0); -ELEMENTS[14968] = Fluid3D([5908,5871,6416,6490],0); -ELEMENTS[14969] = Fluid3D([5871,6416,6490,6432],0); -ELEMENTS[14970] = Fluid3D([5908,6416,6193,6630],0); -ELEMENTS[14971] = Fluid3D([5871,6416,6432,6051],0); -ELEMENTS[14972] = Fluid3D([5908,6416,6630,6490],0); -ELEMENTS[14973] = Fluid3D([5789,5908,6193,5417],0); -ELEMENTS[14974] = Fluid3D([5908,5871,6490,5690],0); -ELEMENTS[14975] = Fluid3D([5908,5871,5690,5328],0); -ELEMENTS[14976] = Fluid3D([5871,6490,5690,6030],0); -ELEMENTS[14977] = Fluid3D([5690,5871,6030,5392],0); -ELEMENTS[14978] = Fluid3D([5690,5871,5392,5328],0); -ELEMENTS[14979] = Fluid3D([5871,6490,6030,6432],0); -ELEMENTS[14980] = Fluid3D([6490,5908,5690,6014],0); -ELEMENTS[14981] = Fluid3D([5908,5690,6014,5448],0); -ELEMENTS[14982] = Fluid3D([5690,6490,6014,6174],0); -ELEMENTS[14983] = Fluid3D([5690,6490,6174,6030],0); -ELEMENTS[14984] = Fluid3D([6490,5908,6014,6630],0); -ELEMENTS[14985] = Fluid3D([5908,5690,5448,5328],0); -ELEMENTS[14986] = Fluid3D([6416,6490,6432,7223],0); -ELEMENTS[14987] = Fluid3D([5413,5038,5004,4816],0); -ELEMENTS[14988] = Fluid3D([5004,5413,4816,5108],0); -ELEMENTS[14989] = Fluid3D([5413,5038,4816,5328],0); -ELEMENTS[14990] = Fluid3D([4816,5004,5108,4491],0); -ELEMENTS[14991] = Fluid3D([4816,5004,4491,4550],0); -ELEMENTS[14992] = Fluid3D([5108,4816,4491,4542],0); -ELEMENTS[14993] = Fluid3D([5108,4816,4542,5392],0); -ELEMENTS[14994] = Fluid3D([4816,5004,4550,5038],0); -ELEMENTS[14995] = Fluid3D([5004,5413,5108,5589],0); -ELEMENTS[14996] = Fluid3D([5413,4816,5108,5392],0); -ELEMENTS[14997] = Fluid3D([6234,6068,5586,5969],0); -ELEMENTS[14998] = Fluid3D([5004,4491,4550,4548],0); -ELEMENTS[14999] = Fluid3D([5004,4491,4548,4813],0); -ELEMENTS[15000] = Fluid3D([4491,4548,4813,4304],0); -ELEMENTS[15001] = Fluid3D([4548,4813,4304,4592],0); -ELEMENTS[15002] = Fluid3D([4548,4813,4592,5077],0); -ELEMENTS[15003] = Fluid3D([4548,4813,5077,5004],0); -ELEMENTS[15004] = Fluid3D([4491,4550,4548,4047],0); -ELEMENTS[15005] = Fluid3D([4491,4550,4047,4212],0); -ELEMENTS[15006] = Fluid3D([4491,4550,4212,4816],0); -ELEMENTS[15007] = Fluid3D([4550,4548,4047,4302],0); -ELEMENTS[15008] = Fluid3D([4548,4047,4302,4084],0); -ELEMENTS[15009] = Fluid3D([4548,4047,4084,4304],0); -ELEMENTS[15010] = Fluid3D([4550,4548,4302,4968],0); -ELEMENTS[15011] = Fluid3D([4548,4302,4968,4603],0); -ELEMENTS[15012] = Fluid3D([4548,4302,4603,4084],0); -ELEMENTS[15013] = Fluid3D([4550,4548,4968,5004],0); -ELEMENTS[15014] = Fluid3D([4491,4548,4304,4047],0); -ELEMENTS[15015] = Fluid3D([5004,4491,4813,5108],0); -ELEMENTS[15016] = Fluid3D([4813,4491,4304,4490],0); -ELEMENTS[15017] = Fluid3D([4813,4491,4490,5108],0); -ELEMENTS[15018] = Fluid3D([4491,4304,4490,4040],0); -ELEMENTS[15019] = Fluid3D([4304,4813,4490,4545],0); -ELEMENTS[15020] = Fluid3D([4304,4813,4545,4592],0); -ELEMENTS[15021] = Fluid3D([4813,4490,4545,5002],0); -ELEMENTS[15022] = Fluid3D([4813,4490,5002,5108],0); -ELEMENTS[15023] = Fluid3D([4545,4813,5002,5100],0); -ELEMENTS[15024] = Fluid3D([4304,4490,4040,4039],0); -ELEMENTS[15025] = Fluid3D([4304,4490,4039,4545],0); -ELEMENTS[15026] = Fluid3D([4813,5002,5100,5589],0); -ELEMENTS[15027] = Fluid3D([4490,4545,5002,4543],0); -ELEMENTS[15028] = Fluid3D([4545,5002,4543,4918],0); -ELEMENTS[15029] = Fluid3D([5002,4490,4543,4811],0); -ELEMENTS[15030] = Fluid3D([4490,4545,4543,4039],0); -ELEMENTS[15031] = Fluid3D([5002,4490,4811,5108],0); -ELEMENTS[15032] = Fluid3D([4545,5002,4918,5100],0); -ELEMENTS[15033] = Fluid3D([4545,4813,5100,4592],0); -ELEMENTS[15034] = Fluid3D([4490,4491,4040,4542],0); -ELEMENTS[15035] = Fluid3D([4491,4304,4040,4047],0); -ELEMENTS[15036] = Fluid3D([6068,6051,5589,6236],0); -ELEMENTS[15037] = Fluid3D([5589,6068,6236,6219],0); -ELEMENTS[15038] = Fluid3D([6051,5589,6236,5839],0); -ELEMENTS[15039] = Fluid3D([6068,6051,6236,6741],0); -ELEMENTS[15040] = Fluid3D([5589,6236,5839,5726],0); -ELEMENTS[15041] = Fluid3D([5839,5589,5726,5108],0); -ELEMENTS[15042] = Fluid3D([5589,6236,5726,6219],0); -ELEMENTS[15043] = Fluid3D([6236,5839,5726,6277],0); -ELEMENTS[15044] = Fluid3D([6236,5839,6277,6468],0); -ELEMENTS[15045] = Fluid3D([6277,6236,6468,6968],0); -ELEMENTS[15046] = Fluid3D([6277,6236,6968,6812],0); -ELEMENTS[15047] = Fluid3D([6236,6968,6812,6970],0); -ELEMENTS[15048] = Fluid3D([6968,6812,6970,7991],0); -ELEMENTS[15049] = Fluid3D([6236,6968,6970,6468],0); -ELEMENTS[15050] = Fluid3D([5726,6236,6277,6812],0); -ELEMENTS[15051] = Fluid3D([6236,5839,6468,6051],0); -ELEMENTS[15052] = Fluid3D([5839,5726,6277,5682],0); -ELEMENTS[15053] = Fluid3D([5839,5726,5682,5108],0); -ELEMENTS[15054] = Fluid3D([5726,6277,5682,5851],0); -ELEMENTS[15055] = Fluid3D([6277,5839,5682,6215],0); -ELEMENTS[15056] = Fluid3D([5839,5682,6215,5416],0); -ELEMENTS[15057] = Fluid3D([6215,5839,5416,6030],0); -ELEMENTS[15058] = Fluid3D([6277,5839,6215,6468],0); -ELEMENTS[15059] = Fluid3D([5839,5682,5416,5108],0); -ELEMENTS[15060] = Fluid3D([5682,6277,6215,6243],0); -ELEMENTS[15061] = Fluid3D([5682,6277,6243,5940],0); -ELEMENTS[15062] = Fluid3D([6243,5682,5940,5628],0); -ELEMENTS[15063] = Fluid3D([6277,6215,6243,6900],0); -ELEMENTS[15064] = Fluid3D([6243,5682,5628,5732],0); -ELEMENTS[15065] = Fluid3D([6243,5682,5732,6215],0); -ELEMENTS[15066] = Fluid3D([6277,6215,6900,6468],0); -ELEMENTS[15067] = Fluid3D([5682,6277,5940,5851],0); -ELEMENTS[15068] = Fluid3D([5682,6215,5416,5732],0); -ELEMENTS[15069] = Fluid3D([6051,5589,5839,5413],0); -ELEMENTS[15070] = Fluid3D([5682,5940,5628,5396],0); -ELEMENTS[15071] = Fluid3D([5940,5628,5396,5923],0); -ELEMENTS[15072] = Fluid3D([5396,5940,5923,5851],0); -ELEMENTS[15073] = Fluid3D([5940,5923,5851,6496],0); -ELEMENTS[15074] = Fluid3D([5940,5923,6496,6458],0); -ELEMENTS[15075] = Fluid3D([5396,5940,5851,5682],0); -ELEMENTS[15076] = Fluid3D([5851,5940,6496,6277],0); -ELEMENTS[15077] = Fluid3D([5940,5923,6458,5628],0); -ELEMENTS[15078] = Fluid3D([5628,5682,5396,5184],0); -ELEMENTS[15079] = Fluid3D([5396,5628,5184,5128],0); -ELEMENTS[15080] = Fluid3D([5396,5628,5128,5351],0); -ELEMENTS[15081] = Fluid3D([5128,5396,5351,4844],0); -ELEMENTS[15082] = Fluid3D([5351,5128,4844,4818],0); -ELEMENTS[15083] = Fluid3D([5351,5128,4818,5340],0); -ELEMENTS[15084] = Fluid3D([5351,5128,5340,5762],0); -ELEMENTS[15085] = Fluid3D([5351,5128,5762,5628],0); -ELEMENTS[15086] = Fluid3D([5128,5762,5628,5484],0); -ELEMENTS[15087] = Fluid3D([5762,5628,5484,6227],0); -ELEMENTS[15088] = Fluid3D([5762,5628,6227,6458],0); -ELEMENTS[15089] = Fluid3D([5628,5484,6227,5732],0); -ELEMENTS[15090] = Fluid3D([5484,5762,6227,5910],0); -ELEMENTS[15091] = Fluid3D([5762,6227,5910,6458],0); -ELEMENTS[15092] = Fluid3D([5484,5762,5910,5340],0); -ELEMENTS[15093] = Fluid3D([5628,5128,5484,5184],0); -ELEMENTS[15094] = Fluid3D([5128,5762,5484,5340],0); -ELEMENTS[15095] = Fluid3D([5340,5351,5762,5855],0); -ELEMENTS[15096] = Fluid3D([4818,5351,5340,5226],0); -ELEMENTS[15097] = Fluid3D([5128,5396,4844,4811],0); -ELEMENTS[15098] = Fluid3D([5351,5340,5226,5855],0); -ELEMENTS[15099] = Fluid3D([4844,5351,4818,4952],0); -ELEMENTS[15100] = Fluid3D([5351,4818,4952,5226],0); -ELEMENTS[15101] = Fluid3D([4844,5351,4952,5402],0); -ELEMENTS[15102] = Fluid3D([5128,4844,4818,4540],0); -ELEMENTS[15103] = Fluid3D([5128,4844,4540,4811],0); -ELEMENTS[15104] = Fluid3D([4818,5128,4540,4747],0); -ELEMENTS[15105] = Fluid3D([4818,5128,4747,5340],0); -ELEMENTS[15106] = Fluid3D([5351,5762,5855,5923],0); -ELEMENTS[15107] = Fluid3D([5351,5762,5923,5628],0); -ELEMENTS[15108] = Fluid3D([5184,5396,5128,4811],0); -ELEMENTS[15109] = Fluid3D([5184,5396,4811,5682],0); -ELEMENTS[15110] = Fluid3D([4540,4818,4747,4348],0); -ELEMENTS[15111] = Fluid3D([5340,4818,5226,4936],0); -ELEMENTS[15112] = Fluid3D([4540,4818,4348,4326],0); -ELEMENTS[15113] = Fluid3D([4540,4818,4326,4844],0); -ELEMENTS[15114] = Fluid3D([4818,5226,4936,4639],0); -ELEMENTS[15115] = Fluid3D([4818,5226,4639,4952],0); -ELEMENTS[15116] = Fluid3D([6227,5484,5910,6052],0); -ELEMENTS[15117] = Fluid3D([5910,6227,6052,6643],0); -ELEMENTS[15118] = Fluid3D([5484,5910,6052,5576],0); -ELEMENTS[15119] = Fluid3D([5484,5910,5576,5340],0); -ELEMENTS[15120] = Fluid3D([6052,5910,6643,6292],0); -ELEMENTS[15121] = Fluid3D([6052,5910,6292,5576],0); -ELEMENTS[15122] = Fluid3D([5910,6643,6292,6691],0); -ELEMENTS[15123] = Fluid3D([5910,6643,6691,6355],0); -ELEMENTS[15124] = Fluid3D([5910,6643,6355,6227],0); -ELEMENTS[15125] = Fluid3D([4818,4747,4348,4936],0); -ELEMENTS[15126] = Fluid3D([5762,5923,5628,6458],0); -ELEMENTS[15127] = Fluid3D([5396,5351,4844,5402],0); -ELEMENTS[15128] = Fluid3D([4818,4844,4952,4326],0); -ELEMENTS[15129] = Fluid3D([5128,4540,4747,4858],0); -ELEMENTS[15130] = Fluid3D([5128,4540,4858,5184],0); -ELEMENTS[15131] = Fluid3D([4747,5128,4858,5484],0); -ELEMENTS[15132] = Fluid3D([5762,5340,5855,5910],0); -ELEMENTS[15133] = Fluid3D([5226,5340,4936,5545],0); -ELEMENTS[15134] = Fluid3D([5226,5340,5545,5855],0); -ELEMENTS[15135] = Fluid3D([4936,4818,4639,4348],0); -ELEMENTS[15136] = Fluid3D([5340,4818,4936,4747],0); -ELEMENTS[15137] = Fluid3D([5628,5682,5184,5732],0); -ELEMENTS[15138] = Fluid3D([4747,4540,4348,4330],0); -ELEMENTS[15139] = Fluid3D([4747,4540,4330,4858],0); -ELEMENTS[15140] = Fluid3D([4540,4348,4330,4017],0); -ELEMENTS[15141] = Fluid3D([4540,4348,4017,4326],0); -ELEMENTS[15142] = Fluid3D([4330,4540,4017,4463],0); -ELEMENTS[15143] = Fluid3D([4017,4330,4463,3816],0); -ELEMENTS[15144] = Fluid3D([4017,4330,3816,3899],0); -ELEMENTS[15145] = Fluid3D([4017,4330,3899,4348],0); -ELEMENTS[15146] = Fluid3D([4330,4540,4463,4858],0); -ELEMENTS[15147] = Fluid3D([4540,4017,4463,4206],0); -ELEMENTS[15148] = Fluid3D([4017,4463,4206,3688],0); -ELEMENTS[15149] = Fluid3D([4463,4206,3688,4129],0); -ELEMENTS[15150] = Fluid3D([4463,4206,4129,4811],0); -ELEMENTS[15151] = Fluid3D([4540,4017,4206,4326],0); -ELEMENTS[15152] = Fluid3D([4017,4463,3688,3816],0); -ELEMENTS[15153] = Fluid3D([4463,4540,4206,4811],0); -ELEMENTS[15154] = Fluid3D([4818,4348,4326,4639],0); -ELEMENTS[15155] = Fluid3D([5226,4936,4639,5049],0); -ELEMENTS[15156] = Fluid3D([5226,4936,5049,5545],0); -ELEMENTS[15157] = Fluid3D([4639,5226,5049,5013],0); -ELEMENTS[15158] = Fluid3D([4639,5226,5013,4952],0); -ELEMENTS[15159] = Fluid3D([5226,5049,5013,5581],0); -ELEMENTS[15160] = Fluid3D([5226,5049,5581,5545],0); -ELEMENTS[15161] = Fluid3D([5013,5226,5581,5517],0); -ELEMENTS[15162] = Fluid3D([4936,4639,5049,4596],0); -ELEMENTS[15163] = Fluid3D([5226,5581,5517,5855],0); -ELEMENTS[15164] = Fluid3D([4936,4639,4596,4348],0); -ELEMENTS[15165] = Fluid3D([5013,5226,5517,4952],0); -ELEMENTS[15166] = Fluid3D([5049,5013,5581,5192],0); -ELEMENTS[15167] = Fluid3D([5049,5013,5192,4620],0); -ELEMENTS[15168] = Fluid3D([5013,5581,5192,5494],0); -ELEMENTS[15169] = Fluid3D([5013,5581,5494,5517],0); -ELEMENTS[15170] = Fluid3D([5013,5192,4620,4840],0); -ELEMENTS[15171] = Fluid3D([5192,4620,4840,4637],0); -ELEMENTS[15172] = Fluid3D([5192,4620,4637,4958],0); -ELEMENTS[15173] = Fluid3D([5192,4620,4958,5049],0); -ELEMENTS[15174] = Fluid3D([5013,5192,4840,5494],0); -ELEMENTS[15175] = Fluid3D([5581,5049,5192,5632],0); -ELEMENTS[15176] = Fluid3D([5581,5049,5632,5545],0); -ELEMENTS[15177] = Fluid3D([5049,5192,5632,4958],0); -ELEMENTS[15178] = Fluid3D([5049,5013,4620,4639],0); -ELEMENTS[15179] = Fluid3D([5049,4936,4596,5010],0); -ELEMENTS[15180] = Fluid3D([5049,4936,5010,5545],0); -ELEMENTS[15181] = Fluid3D([4596,5049,5010,4958],0); -ELEMENTS[15182] = Fluid3D([4936,4596,5010,4622],0); -ELEMENTS[15183] = Fluid3D([5010,4936,4622,5205],0); -ELEMENTS[15184] = Fluid3D([4936,4596,4622,4348],0); -ELEMENTS[15185] = Fluid3D([4622,5010,5205,4964],0); -ELEMENTS[15186] = Fluid3D([5010,5205,4964,5475],0); -ELEMENTS[15187] = Fluid3D([5010,5205,5475,5545],0); -ELEMENTS[15188] = Fluid3D([4622,5010,4964,4570],0); -ELEMENTS[15189] = Fluid3D([4622,5010,4570,4596],0); -ELEMENTS[15190] = Fluid3D([5010,4964,4570,5106],0); -ELEMENTS[15191] = Fluid3D([5010,4964,5106,5475],0); -ELEMENTS[15192] = Fluid3D([4570,5010,5106,4882],0); -ELEMENTS[15193] = Fluid3D([4570,5010,4882,4596],0); -ELEMENTS[15194] = Fluid3D([5010,5106,4882,5406],0); -ELEMENTS[15195] = Fluid3D([5010,5106,5406,5475],0); -ELEMENTS[15196] = Fluid3D([5106,4882,5406,5197],0); -ELEMENTS[15197] = Fluid3D([5106,4882,5197,4659],0); -ELEMENTS[15198] = Fluid3D([5106,4882,4659,4570],0); -ELEMENTS[15199] = Fluid3D([4882,5406,5197,4958],0); -ELEMENTS[15200] = Fluid3D([4882,5406,4958,5010],0); -ELEMENTS[15201] = Fluid3D([5197,4882,4958,4624],0); -ELEMENTS[15202] = Fluid3D([4882,4958,4624,4428],0); -ELEMENTS[15203] = Fluid3D([4882,4958,4428,4596],0); -ELEMENTS[15204] = Fluid3D([4624,4882,4428,4659],0); -ELEMENTS[15205] = Fluid3D([4624,4882,4659,5197],0); -ELEMENTS[15206] = Fluid3D([4958,4624,4428,4637],0); -ELEMENTS[15207] = Fluid3D([4659,4624,5197,4807],0); -ELEMENTS[15208] = Fluid3D([4659,4624,4807,4268],0); -ELEMENTS[15209] = Fluid3D([4659,4624,4268,4224],0); -ELEMENTS[15210] = Fluid3D([4659,4624,4224,4428],0); -ELEMENTS[15211] = Fluid3D([4624,4224,4428,4070],0); -ELEMENTS[15212] = Fluid3D([4224,4428,4070,3873],0); -ELEMENTS[15213] = Fluid3D([4224,4428,3873,4213],0); -ELEMENTS[15214] = Fluid3D([4224,4428,4213,4570],0); -ELEMENTS[15215] = Fluid3D([4213,4224,4570,4112],0); -ELEMENTS[15216] = Fluid3D([4570,4213,4112,4622],0); -ELEMENTS[15217] = Fluid3D([3873,4224,4213,4112],0); -ELEMENTS[15218] = Fluid3D([4070,4224,3873,3783],0); -ELEMENTS[15219] = Fluid3D([4428,3873,4213,4107],0); -ELEMENTS[15220] = Fluid3D([4428,4070,3873,4117],0); -ELEMENTS[15221] = Fluid3D([4224,3873,3783,4112],0); -ELEMENTS[15222] = Fluid3D([4213,4428,4107,4596],0); -ELEMENTS[15223] = Fluid3D([4107,4213,4596,4154],0); -ELEMENTS[15224] = Fluid3D([4213,4596,4154,4622],0); -ELEMENTS[15225] = Fluid3D([4213,4428,4596,4570],0); -ELEMENTS[15226] = Fluid3D([4596,4213,4570,4622],0); -ELEMENTS[15227] = Fluid3D([4596,4107,4154,4639],0); -ELEMENTS[15228] = Fluid3D([4428,4107,4596,4620],0); -ELEMENTS[15229] = Fluid3D([4070,4224,3783,4268],0); -ELEMENTS[15230] = Fluid3D([4428,3873,4107,4117],0); -ELEMENTS[15231] = Fluid3D([4428,4070,4117,4378],0); -ELEMENTS[15232] = Fluid3D([4807,4659,4268,4601],0); -ELEMENTS[15233] = Fluid3D([4428,4070,4378,4624],0); -ELEMENTS[15234] = Fluid3D([4268,4659,4224,4204],0); -ELEMENTS[15235] = Fluid3D([4659,4268,4601,4204],0); -ELEMENTS[15236] = Fluid3D([4659,4224,4204,4570],0); -ELEMENTS[15237] = Fluid3D([4107,4213,4154,3782],0); -ELEMENTS[15238] = Fluid3D([4213,4154,3782,3995],0); -ELEMENTS[15239] = Fluid3D([4213,4154,3995,4622],0); -ELEMENTS[15240] = Fluid3D([4624,4268,4224,4070],0); -ELEMENTS[15241] = Fluid3D([4807,4659,4601,5105],0); -ELEMENTS[15242] = Fluid3D([4807,4659,5105,5197],0); -ELEMENTS[15243] = Fluid3D([4659,5105,5197,5106],0); -ELEMENTS[15244] = Fluid3D([3782,4213,3995,4112],0); -ELEMENTS[15245] = Fluid3D([4107,4428,4117,4620],0); -ELEMENTS[15246] = Fluid3D([4117,4428,4378,4637],0); -ELEMENTS[15247] = Fluid3D([4659,4601,5105,4742],0); -ELEMENTS[15248] = Fluid3D([4659,4601,4742,4204],0); -ELEMENTS[15249] = Fluid3D([4624,4807,4268,4450],0); -ELEMENTS[15250] = Fluid3D([4268,4624,4450,4070],0); -ELEMENTS[15251] = Fluid3D([4601,4807,5105,5003],0); -ELEMENTS[15252] = Fluid3D([4807,5105,5003,5415],0); -ELEMENTS[15253] = Fluid3D([4807,5105,5415,5197],0); -ELEMENTS[15254] = Fluid3D([4070,3873,4117,3646],0); -ELEMENTS[15255] = Fluid3D([3873,4117,3646,3699],0); -ELEMENTS[15256] = Fluid3D([3873,4117,3699,4107],0); -ELEMENTS[15257] = Fluid3D([4601,4807,5003,4480],0); -ELEMENTS[15258] = Fluid3D([4601,4807,4480,4268],0); -ELEMENTS[15259] = Fluid3D([4117,4070,3646,3960],0); -ELEMENTS[15260] = Fluid3D([4117,4070,3960,4378],0); -ELEMENTS[15261] = Fluid3D([4807,5003,4480,4977],0); -ELEMENTS[15262] = Fluid3D([3646,4117,3960,3687],0); -ELEMENTS[15263] = Fluid3D([4807,5003,4977,5415],0); -ELEMENTS[15264] = Fluid3D([3646,4117,3687,3699],0); -ELEMENTS[15265] = Fluid3D([4107,4213,3782,3873],0); -ELEMENTS[15266] = Fluid3D([4213,3782,3873,4112],0); -ELEMENTS[15267] = Fluid3D([3782,4107,3873,3699],0); -ELEMENTS[15268] = Fluid3D([3873,4070,3783,3646],0); -ELEMENTS[15269] = Fluid3D([4601,5105,4742,4765],0); -ELEMENTS[15270] = Fluid3D([4224,4268,4204,3783],0); -ELEMENTS[15271] = Fluid3D([4213,3995,4112,4622],0); -ELEMENTS[15272] = Fluid3D([5105,5003,5415,5570],0); -ELEMENTS[15273] = Fluid3D([5415,5105,5570,5748],0); -ELEMENTS[15274] = Fluid3D([5415,5105,5748,5197],0); -ELEMENTS[15275] = Fluid3D([5105,4659,4742,5106],0); -ELEMENTS[15276] = Fluid3D([4154,3782,3995,3728],0); -ELEMENTS[15277] = Fluid3D([3995,4154,3728,3899],0); -ELEMENTS[15278] = Fluid3D([4154,3728,3899,3885],0); -ELEMENTS[15279] = Fluid3D([3728,3899,3885,3515],0); -ELEMENTS[15280] = Fluid3D([3728,3899,3515,3573],0); -ELEMENTS[15281] = Fluid3D([3728,3899,3573,3995],0); -ELEMENTS[15282] = Fluid3D([3885,3728,3515,3467],0); -ELEMENTS[15283] = Fluid3D([3515,3728,3573,3379],0); -ELEMENTS[15284] = Fluid3D([3885,3728,3467,3782],0); -ELEMENTS[15285] = Fluid3D([3728,3515,3467,3379],0); -ELEMENTS[15286] = Fluid3D([3467,3728,3379,3782],0); -ELEMENTS[15287] = Fluid3D([3515,3467,3379,3141],0); -ELEMENTS[15288] = Fluid3D([3467,3379,3141,3108],0); -ELEMENTS[15289] = Fluid3D([3467,3379,3108,3420],0); -ELEMENTS[15290] = Fluid3D([3467,3379,3420,3782],0); -ELEMENTS[15291] = Fluid3D([3420,3467,3782,3699],0); -ELEMENTS[15292] = Fluid3D([3728,3573,3379,3564],0); -ELEMENTS[15293] = Fluid3D([3728,3573,3564,3995],0); -ELEMENTS[15294] = Fluid3D([3564,3728,3995,3782],0); -ELEMENTS[15295] = Fluid3D([3899,3515,3573,3816],0); -ELEMENTS[15296] = Fluid3D([3379,3728,3564,3782],0); -ELEMENTS[15297] = Fluid3D([3379,3108,3420,3064],0); -ELEMENTS[15298] = Fluid3D([3108,3467,3420,3349],0); -ELEMENTS[15299] = Fluid3D([3379,3141,3108,2899],0); -ELEMENTS[15300] = Fluid3D([3379,3108,3064,2899],0); -ELEMENTS[15301] = Fluid3D([3108,3467,3349,3222],0); -ELEMENTS[15302] = Fluid3D([3108,3467,3222,3141],0); -ELEMENTS[15303] = Fluid3D([3379,3141,2899,3125],0); -ELEMENTS[15304] = Fluid3D([3379,3141,3125,3515],0); -ELEMENTS[15305] = Fluid3D([3420,3379,3064,3564],0); -ELEMENTS[15306] = Fluid3D([3467,3420,3349,3699],0); -ELEMENTS[15307] = Fluid3D([3420,3349,3699,3223],0); -ELEMENTS[15308] = Fluid3D([3349,3699,3223,3333],0); -ELEMENTS[15309] = Fluid3D([3349,3699,3333,3676],0); -ELEMENTS[15310] = Fluid3D([3349,3699,3676,3467],0); -ELEMENTS[15311] = Fluid3D([3223,3349,3333,3027],0); -ELEMENTS[15312] = Fluid3D([3333,3349,3676,3266],0); -ELEMENTS[15313] = Fluid3D([3223,3349,3027,3108],0); -ELEMENTS[15314] = Fluid3D([3349,3333,3027,3266],0); -ELEMENTS[15315] = Fluid3D([3027,3349,3266,3222],0); -ELEMENTS[15316] = Fluid3D([3349,3266,3222,3676],0); -ELEMENTS[15317] = Fluid3D([3699,3333,3676,3687],0); -ELEMENTS[15318] = Fluid3D([3333,3027,3266,3017],0); -ELEMENTS[15319] = Fluid3D([3027,3266,3017,2885],0); -ELEMENTS[15320] = Fluid3D([3027,3266,2885,3222],0); -ELEMENTS[15321] = Fluid3D([3349,3027,3108,3222],0); -ELEMENTS[15322] = Fluid3D([3699,3223,3333,3646],0); -ELEMENTS[15323] = Fluid3D([3266,3017,2885,3111],0); -ELEMENTS[15324] = Fluid3D([3899,3885,3515,4017],0); -ELEMENTS[15325] = Fluid3D([3899,3885,4017,4348],0); -ELEMENTS[15326] = Fluid3D([3885,4017,4348,4326],0); -ELEMENTS[15327] = Fluid3D([3885,4017,4326,3829],0); -ELEMENTS[15328] = Fluid3D([3885,4017,3829,3515],0); -ELEMENTS[15329] = Fluid3D([2885,3266,3111,3157],0); -ELEMENTS[15330] = Fluid3D([2885,3266,3157,3222],0); -ELEMENTS[15331] = Fluid3D([3266,3157,3222,3560],0); -ELEMENTS[15332] = Fluid3D([3222,3266,3560,3676],0); -ELEMENTS[15333] = Fluid3D([3017,3027,2885,2716],0); -ELEMENTS[15334] = Fluid3D([3027,2885,2716,2746],0); -ELEMENTS[15335] = Fluid3D([3017,3027,2716,2946],0); -ELEMENTS[15336] = Fluid3D([3017,3027,2946,3333],0); -ELEMENTS[15337] = Fluid3D([3027,2885,2746,3222],0); -ELEMENTS[15338] = Fluid3D([3467,3349,3222,3676],0); -ELEMENTS[15339] = Fluid3D([3266,3017,3111,3404],0); -ELEMENTS[15340] = Fluid3D([3266,3017,3404,3333],0); -ELEMENTS[15341] = Fluid3D([3515,3467,3141,3485],0); -ELEMENTS[15342] = Fluid3D([3467,3141,3485,3222],0); -ELEMENTS[15343] = Fluid3D([2899,3379,3125,3114],0); -ELEMENTS[15344] = Fluid3D([3573,3379,3564,3114],0); -ELEMENTS[15345] = Fluid3D([3266,3157,3560,3442],0); -ELEMENTS[15346] = Fluid3D([3560,3266,3442,3676],0); -ELEMENTS[15347] = Fluid3D([3379,3125,3114,3573],0); -ELEMENTS[15348] = Fluid3D([4154,3782,3728,3885],0); -ELEMENTS[15349] = Fluid3D([3141,2899,3125,2841],0); -ELEMENTS[15350] = Fluid3D([3125,3141,2841,3203],0); -ELEMENTS[15351] = Fluid3D([3125,3141,3203,3515],0); -ELEMENTS[15352] = Fluid3D([3141,2899,2841,2858],0); -ELEMENTS[15353] = Fluid3D([3141,2899,2858,3108],0); -ELEMENTS[15354] = Fluid3D([2841,3141,2858,2963],0); -ELEMENTS[15355] = Fluid3D([2841,3141,2963,3203],0); -ELEMENTS[15356] = Fluid3D([3027,2716,2946,2774],0); -ELEMENTS[15357] = Fluid3D([3027,2716,2774,2746],0); -ELEMENTS[15358] = Fluid3D([2946,3027,2774,3223],0); -ELEMENTS[15359] = Fluid3D([3108,3420,3064,3223],0); -ELEMENTS[15360] = Fluid3D([3017,3111,3404,3116],0); -ELEMENTS[15361] = Fluid3D([3404,3017,3116,3179],0); -ELEMENTS[15362] = Fluid3D([3017,3111,3116,2783],0); -ELEMENTS[15363] = Fluid3D([3017,3111,2783,2885],0); -ELEMENTS[15364] = Fluid3D([3404,3017,3179,3333],0); -ELEMENTS[15365] = Fluid3D([3266,3157,3442,3111],0); -ELEMENTS[15366] = Fluid3D([3442,3266,3111,3404],0); -ELEMENTS[15367] = Fluid3D([3111,3442,3404,3374],0); -ELEMENTS[15368] = Fluid3D([3111,3442,3374,3231],0); -ELEMENTS[15369] = Fluid3D([3111,3442,3231,3157],0); -ELEMENTS[15370] = Fluid3D([3442,3374,3231,3654],0); -ELEMENTS[15371] = Fluid3D([3374,3111,3231,2987],0); -ELEMENTS[15372] = Fluid3D([3442,3374,3654,3764],0); -ELEMENTS[15373] = Fluid3D([3442,3404,3374,3764],0); -ELEMENTS[15374] = Fluid3D([3231,3442,3654,3528],0); -ELEMENTS[15375] = Fluid3D([3231,3442,3528,3157],0); -ELEMENTS[15376] = Fluid3D([3111,3231,2987,2865],0); -ELEMENTS[15377] = Fluid3D([3111,3231,2865,3157],0); -ELEMENTS[15378] = Fluid3D([3442,3404,3764,3676],0); -ELEMENTS[15379] = Fluid3D([3374,3111,2987,3116],0); -ELEMENTS[15380] = Fluid3D([3442,3266,3404,3676],0); -ELEMENTS[15381] = Fluid3D([3374,3111,3116,3404],0); -ELEMENTS[15382] = Fluid3D([3442,3654,3528,3874],0); -ELEMENTS[15383] = Fluid3D([3442,3654,3874,3764],0); -ELEMENTS[15384] = Fluid3D([3528,3442,3874,3560],0); -ELEMENTS[15385] = Fluid3D([2987,3111,2865,2783],0); -ELEMENTS[15386] = Fluid3D([3374,3654,3764,3810],0); -ELEMENTS[15387] = Fluid3D([3231,2987,2865,2954],0); -ELEMENTS[15388] = Fluid3D([3374,3231,3654,3410],0); -ELEMENTS[15389] = Fluid3D([3231,2987,2954,3410],0); -ELEMENTS[15390] = Fluid3D([3654,3374,3410,3810],0); -ELEMENTS[15391] = Fluid3D([3231,3654,3410,3482],0); -ELEMENTS[15392] = Fluid3D([3231,3654,3482,3528],0); -ELEMENTS[15393] = Fluid3D([3654,3410,3482,3840],0); -ELEMENTS[15394] = Fluid3D([3654,3410,3840,3810],0); -ELEMENTS[15395] = Fluid3D([3482,3654,3840,3986],0); -ELEMENTS[15396] = Fluid3D([3482,3654,3986,3528],0); -ELEMENTS[15397] = Fluid3D([3231,3374,2987,3410],0); -ELEMENTS[15398] = Fluid3D([3404,3374,3764,3600],0); -ELEMENTS[15399] = Fluid3D([3374,3764,3600,3810],0); -ELEMENTS[15400] = Fluid3D([3764,3404,3600,3794],0); -ELEMENTS[15401] = Fluid3D([3600,3764,3794,4052],0); -ELEMENTS[15402] = Fluid3D([3600,3764,4052,3810],0); -ELEMENTS[15403] = Fluid3D([3764,3404,3794,3676],0); -ELEMENTS[15404] = Fluid3D([3764,3794,4052,4193],0); -ELEMENTS[15405] = Fluid3D([3764,3794,4193,3676],0); -ELEMENTS[15406] = Fluid3D([4052,3764,4193,4203],0); -ELEMENTS[15407] = Fluid3D([4052,3764,4203,3810],0); -ELEMENTS[15408] = Fluid3D([2885,2716,2746,2557],0); -ELEMENTS[15409] = Fluid3D([2746,2885,2557,2750],0); -ELEMENTS[15410] = Fluid3D([2746,2885,2750,3222],0); -ELEMENTS[15411] = Fluid3D([2885,2716,2557,2783],0); -ELEMENTS[15412] = Fluid3D([3333,3223,3027,2946],0); -ELEMENTS[15413] = Fluid3D([3515,3885,3467,3485],0); -ELEMENTS[15414] = Fluid3D([3654,3528,3874,3986],0); -ELEMENTS[15415] = Fluid3D([3420,3349,3223,3108],0); -ELEMENTS[15416] = Fluid3D([3125,2899,3114,2854],0); -ELEMENTS[15417] = Fluid3D([2899,3114,2854,2749],0); -ELEMENTS[15418] = Fluid3D([2899,3114,2749,3064],0); -ELEMENTS[15419] = Fluid3D([2885,3017,2716,2783],0); -ELEMENTS[15420] = Fluid3D([2716,3017,2946,2739],0); -ELEMENTS[15421] = Fluid3D([3017,2946,2739,3179],0); -ELEMENTS[15422] = Fluid3D([2716,3017,2739,2783],0); -ELEMENTS[15423] = Fluid3D([3573,3515,3379,3125],0); -ELEMENTS[15424] = Fluid3D([2865,3231,2954,3050],0); -ELEMENTS[15425] = Fluid3D([2865,3231,3050,3157],0); -ELEMENTS[15426] = Fluid3D([3231,2954,3050,3482],0); -ELEMENTS[15427] = Fluid3D([2954,2865,3050,2665],0); -ELEMENTS[15428] = Fluid3D([2865,3050,2665,2801],0); -ELEMENTS[15429] = Fluid3D([2865,3050,2801,3157],0); -ELEMENTS[15430] = Fluid3D([2954,2865,2665,2666],0); -ELEMENTS[15431] = Fluid3D([3654,3764,3810,4203],0); -ELEMENTS[15432] = Fluid3D([2899,3379,3114,3064],0); -ELEMENTS[15433] = Fluid3D([3676,3333,3266,3404],0); -ELEMENTS[15434] = Fluid3D([3111,2885,3157,2865],0); -ELEMENTS[15435] = Fluid3D([5105,5003,5570,4975],0); -ELEMENTS[15436] = Fluid3D([5003,4601,4480,4557],0); -ELEMENTS[15437] = Fluid3D([5003,4601,4557,4975],0); -ELEMENTS[15438] = Fluid3D([4557,5003,4975,4955],0); -ELEMENTS[15439] = Fluid3D([4975,4557,4955,4965],0); -ELEMENTS[15440] = Fluid3D([5003,4975,4955,5482],0); -ELEMENTS[15441] = Fluid3D([5003,4975,5482,5570],0); -ELEMENTS[15442] = Fluid3D([5482,5003,5570,5415],0); -ELEMENTS[15443] = Fluid3D([4975,4955,5482,4965],0); -ELEMENTS[15444] = Fluid3D([4975,5482,5570,5622],0); -ELEMENTS[15445] = Fluid3D([4557,5003,4955,4480],0); -ELEMENTS[15446] = Fluid3D([4955,5003,5482,5309],0); -ELEMENTS[15447] = Fluid3D([5003,5482,5309,5415],0); -ELEMENTS[15448] = Fluid3D([5482,4955,5309,5507],0); -ELEMENTS[15449] = Fluid3D([5309,5482,5507,5945],0); -ELEMENTS[15450] = Fluid3D([5482,5507,5945,5982],0); -ELEMENTS[15451] = Fluid3D([4955,5003,5309,4977],0); -ELEMENTS[15452] = Fluid3D([5003,5309,4977,5415],0); -ELEMENTS[15453] = Fluid3D([5482,5507,5982,5622],0); -ELEMENTS[15454] = Fluid3D([5309,5482,5945,5415],0); -ELEMENTS[15455] = Fluid3D([5482,4955,5507,4965],0); -ELEMENTS[15456] = Fluid3D([5945,5482,5982,6117],0); -ELEMENTS[15457] = Fluid3D([5507,5309,5945,5794],0); -ELEMENTS[15458] = Fluid3D([4955,5309,5507,5139],0); -ELEMENTS[15459] = Fluid3D([4958,4882,5010,4596],0); -ELEMENTS[15460] = Fluid3D([5570,5415,5748,6050],0); -ELEMENTS[15461] = Fluid3D([5415,5748,6050,6000],0); -ELEMENTS[15462] = Fluid3D([5570,5415,6050,5945],0); -ELEMENTS[15463] = Fluid3D([5748,5570,6050,6167],0); -ELEMENTS[15464] = Fluid3D([5570,6050,6167,6117],0); -ELEMENTS[15465] = Fluid3D([6050,6167,6117,6867],0); -ELEMENTS[15466] = Fluid3D([6167,5570,6117,5853],0); -ELEMENTS[15467] = Fluid3D([6167,6117,6867,6631],0); -ELEMENTS[15468] = Fluid3D([6117,6167,5853,6631],0); -ELEMENTS[15469] = Fluid3D([5570,6050,6117,5945],0); -ELEMENTS[15470] = Fluid3D([6117,6050,6867,5945],0); -ELEMENTS[15471] = Fluid3D([5570,6117,5853,5622],0); -ELEMENTS[15472] = Fluid3D([6117,6867,6631,6795],0); -ELEMENTS[15473] = Fluid3D([6117,6867,6795,5945],0); -ELEMENTS[15474] = Fluid3D([6631,6117,6795,6142],0); -ELEMENTS[15475] = Fluid3D([6631,6117,6142,5853],0); -ELEMENTS[15476] = Fluid3D([6867,6167,6631,6936],0); -ELEMENTS[15477] = Fluid3D([6167,6631,6936,6390],0); -ELEMENTS[15478] = Fluid3D([6167,6631,6390,5853],0); -ELEMENTS[15479] = Fluid3D([6117,6795,6142,5982],0); -ELEMENTS[15480] = Fluid3D([6142,6117,5982,5622],0); -ELEMENTS[15481] = Fluid3D([5982,6142,5622,6106],0); -ELEMENTS[15482] = Fluid3D([5982,6142,6106,6672],0); -ELEMENTS[15483] = Fluid3D([5982,6142,6672,6795],0); -ELEMENTS[15484] = Fluid3D([6142,6672,6795,7079],0); -ELEMENTS[15485] = Fluid3D([6672,6795,7079,7482],0); -ELEMENTS[15486] = Fluid3D([6672,6795,7482,6897],0); -ELEMENTS[15487] = Fluid3D([6672,6795,6897,5982],0); -ELEMENTS[15488] = Fluid3D([6142,5622,6106,6153],0); -ELEMENTS[15489] = Fluid3D([6142,6106,6672,7079],0); -ELEMENTS[15490] = Fluid3D([6106,5982,6672,6273],0); -ELEMENTS[15491] = Fluid3D([7482,6672,6897,7212],0); -ELEMENTS[15492] = Fluid3D([7079,6672,7482,7296],0); -ELEMENTS[15493] = Fluid3D([5622,5982,6106,5543],0); -ELEMENTS[15494] = Fluid3D([5982,6672,6273,6897],0); -ELEMENTS[15495] = Fluid3D([5982,6106,5543,6273],0); -ELEMENTS[15496] = Fluid3D([6795,7482,6897,7409],0); -ELEMENTS[15497] = Fluid3D([7079,6672,7296,6106],0); -ELEMENTS[15498] = Fluid3D([6795,7079,7482,7520],0); -ELEMENTS[15499] = Fluid3D([6672,7482,7296,7212],0); -ELEMENTS[15500] = Fluid3D([6672,6897,7212,6273],0); -ELEMENTS[15501] = Fluid3D([6795,7482,7409,7520],0); -ELEMENTS[15502] = Fluid3D([6897,6795,7409,6563],0); -ELEMENTS[15503] = Fluid3D([6897,6795,6563,5945],0); -ELEMENTS[15504] = Fluid3D([5622,5982,5543,5507],0); -ELEMENTS[15505] = Fluid3D([5982,5543,5507,6273],0); -ELEMENTS[15506] = Fluid3D([6795,7079,7520,6631],0); -ELEMENTS[15507] = Fluid3D([6795,7409,6563,6867],0); -ELEMENTS[15508] = Fluid3D([6867,6167,6936,6541],0); -ELEMENTS[15509] = Fluid3D([6867,6167,6541,6050],0); -ELEMENTS[15510] = Fluid3D([7296,6672,7212,6606],0); -ELEMENTS[15511] = Fluid3D([7296,6672,6606,6106],0); -ELEMENTS[15512] = Fluid3D([6672,6606,6106,6273],0); -ELEMENTS[15513] = Fluid3D([6606,6106,6273,5932],0); -ELEMENTS[15514] = Fluid3D([6273,6606,5932,6258],0); -ELEMENTS[15515] = Fluid3D([6672,6606,6273,7212],0); -ELEMENTS[15516] = Fluid3D([6606,6106,5932,6301],0); -ELEMENTS[15517] = Fluid3D([6606,6106,6301,6724],0); -ELEMENTS[15518] = Fluid3D([6606,6106,6724,7296],0); -ELEMENTS[15519] = Fluid3D([6724,6606,7296,7152],0); -ELEMENTS[15520] = Fluid3D([7296,6724,7152,7573],0); -ELEMENTS[15521] = Fluid3D([7296,6724,7573,7079],0); -ELEMENTS[15522] = Fluid3D([7296,6724,7079,6106],0); -ELEMENTS[15523] = Fluid3D([6724,7152,7573,6871],0); -ELEMENTS[15524] = Fluid3D([7152,7296,7573,7994],0); -ELEMENTS[15525] = Fluid3D([7573,6724,6871,6964],0); -ELEMENTS[15526] = Fluid3D([7573,6724,6964,7079],0); -ELEMENTS[15527] = Fluid3D([6724,7152,6871,6301],0); -ELEMENTS[15528] = Fluid3D([7152,7296,7994,7411],0); -ELEMENTS[15529] = Fluid3D([7296,7573,7994,8056],0); -ELEMENTS[15530] = Fluid3D([7296,7573,8056,7079],0); -ELEMENTS[15531] = Fluid3D([7152,7296,7411,6606],0); -ELEMENTS[15532] = Fluid3D([6724,6871,6964,6153],0); -ELEMENTS[15533] = Fluid3D([5932,6606,6301,6479],0); -ELEMENTS[15534] = Fluid3D([7296,7994,7411,7959],0); -ELEMENTS[15535] = Fluid3D([5932,6606,6479,6376],0); -ELEMENTS[15536] = Fluid3D([7296,7994,7959,8056],0); -ELEMENTS[15537] = Fluid3D([7296,7411,6606,7212],0); -ELEMENTS[15538] = Fluid3D([7411,6606,7212,7032],0); -ELEMENTS[15539] = Fluid3D([7296,7411,7212,7959],0); -ELEMENTS[15540] = Fluid3D([7411,7212,7959,7855],0); -ELEMENTS[15541] = Fluid3D([7212,7411,7032,7855],0); -ELEMENTS[15542] = Fluid3D([7212,7296,7959,7482],0); -ELEMENTS[15543] = Fluid3D([7959,7212,7482,7763],0); -ELEMENTS[15544] = Fluid3D([7959,7212,7763,7855],0); -ELEMENTS[15545] = Fluid3D([7482,7959,7763,8341],0); -ELEMENTS[15546] = Fluid3D([7482,7959,8341,8056],0); -ELEMENTS[15547] = Fluid3D([7296,7959,7482,8056],0); -ELEMENTS[15548] = Fluid3D([7959,7763,8341,8603],0); -ELEMENTS[15549] = Fluid3D([7959,7763,8603,7855],0); -ELEMENTS[15550] = Fluid3D([6724,6606,7152,6301],0); -ELEMENTS[15551] = Fluid3D([8341,7959,8603,8708],0); -ELEMENTS[15552] = Fluid3D([6106,6273,5932,5543],0); -ELEMENTS[15553] = Fluid3D([7573,7994,8056,8483],0); -ELEMENTS[15554] = Fluid3D([6606,6301,6479,7152],0); -ELEMENTS[15555] = Fluid3D([8341,7959,8708,8056],0); -ELEMENTS[15556] = Fluid3D([6795,6142,7079,6631],0); -ELEMENTS[15557] = Fluid3D([6167,5570,5853,5612],0); -ELEMENTS[15558] = Fluid3D([5853,6167,5612,6390],0); -ELEMENTS[15559] = Fluid3D([7212,7482,7763,6897],0); -ELEMENTS[15560] = Fluid3D([6871,7573,6964,7413],0); -ELEMENTS[15561] = Fluid3D([7573,6964,7413,7803],0); -ELEMENTS[15562] = Fluid3D([6867,6631,6795,7520],0); -ELEMENTS[15563] = Fluid3D([6936,6867,6541,7311],0); -ELEMENTS[15564] = Fluid3D([5570,5853,5612,5166],0); -ELEMENTS[15565] = Fluid3D([5570,5853,5166,5622],0); -ELEMENTS[15566] = Fluid3D([6936,6867,7311,7520],0); -ELEMENTS[15567] = Fluid3D([7482,7079,7296,8056],0); -ELEMENTS[15568] = Fluid3D([7994,7411,7959,8297],0); -ELEMENTS[15569] = Fluid3D([7959,7994,8297,8708],0); -ELEMENTS[15570] = Fluid3D([7411,7959,8297,7855],0); -ELEMENTS[15571] = Fluid3D([7763,7482,8341,7409],0); -ELEMENTS[15572] = Fluid3D([6631,6936,6390,7188],0); -ELEMENTS[15573] = Fluid3D([6390,6631,7188,6532],0); -ELEMENTS[15574] = Fluid3D([6390,6631,6532,5853],0); -ELEMENTS[15575] = Fluid3D([6631,6936,7188,7520],0); -ELEMENTS[15576] = Fluid3D([6631,7188,6532,7079],0); -ELEMENTS[15577] = Fluid3D([7413,7573,7803,8483],0); -ELEMENTS[15578] = Fluid3D([7188,6390,6532,6805],0); -ELEMENTS[15579] = Fluid3D([6871,6724,6301,6153],0); -ELEMENTS[15580] = Fluid3D([6301,6871,6153,5778],0); -ELEMENTS[15581] = Fluid3D([6724,6301,6153,6106],0); -ELEMENTS[15582] = Fluid3D([6301,6153,6106,5669],0); -ELEMENTS[15583] = Fluid3D([6301,6153,5669,5778],0); -ELEMENTS[15584] = Fluid3D([6106,6301,5669,5932],0); -ELEMENTS[15585] = Fluid3D([6301,5669,5932,5847],0); -ELEMENTS[15586] = Fluid3D([6301,5669,5847,5778],0); -ELEMENTS[15587] = Fluid3D([5932,6301,5847,6479],0); -ELEMENTS[15588] = Fluid3D([8603,8341,8708,9252],0); -ELEMENTS[15589] = Fluid3D([8341,8708,9252,9057],0); -ELEMENTS[15590] = Fluid3D([8341,8708,9057,8056],0); -ELEMENTS[15591] = Fluid3D([7573,6964,7803,7079],0); -ELEMENTS[15592] = Fluid3D([6117,6142,5853,5622],0); -ELEMENTS[15593] = Fluid3D([7152,7573,6871,7641],0); -ELEMENTS[15594] = Fluid3D([7573,6871,7641,7413],0); -ELEMENTS[15595] = Fluid3D([6871,7152,7641,6898],0); -ELEMENTS[15596] = Fluid3D([6871,7152,6898,6301],0); -ELEMENTS[15597] = Fluid3D([7641,6871,6898,7081],0); -ELEMENTS[15598] = Fluid3D([7641,6871,7081,7413],0); -ELEMENTS[15599] = Fluid3D([6871,6898,7081,6278],0); -ELEMENTS[15600] = Fluid3D([6871,6898,6278,6301],0); -ELEMENTS[15601] = Fluid3D([6563,6795,6867,5945],0); -ELEMENTS[15602] = Fluid3D([7763,8341,8603,8515],0); -ELEMENTS[15603] = Fluid3D([8603,7763,8515,8251],0); -ELEMENTS[15604] = Fluid3D([7763,8515,8251,8140],0); -ELEMENTS[15605] = Fluid3D([8603,7763,8251,7855],0); -ELEMENTS[15606] = Fluid3D([8515,8603,8251,9592],0); -ELEMENTS[15607] = Fluid3D([8341,8603,8515,9252],0); -ELEMENTS[15608] = Fluid3D([7763,8341,8515,7409],0); -ELEMENTS[15609] = Fluid3D([7482,6897,7409,7763],0); -ELEMENTS[15610] = Fluid3D([5853,5612,5166,5409],0); -ELEMENTS[15611] = Fluid3D([7411,7152,6606,6479],0); -ELEMENTS[15612] = Fluid3D([7994,8056,8483,8708],0); -ELEMENTS[15613] = Fluid3D([6106,5622,5543,5669],0); -ELEMENTS[15614] = Fluid3D([6964,6871,7413,6299],0); -ELEMENTS[15615] = Fluid3D([6479,5932,6376,5847],0); -ELEMENTS[15616] = Fluid3D([6167,5570,5612,5748],0); -ELEMENTS[15617] = Fluid3D([6936,6167,6390,6330],0); -ELEMENTS[15618] = Fluid3D([6936,6167,6330,6541],0); -ELEMENTS[15619] = Fluid3D([6167,6390,6330,5612],0); -ELEMENTS[15620] = Fluid3D([6390,6936,6330,6978],0); -ELEMENTS[15621] = Fluid3D([6936,6330,6978,7096],0); -ELEMENTS[15622] = Fluid3D([6936,6330,7096,6541],0); -ELEMENTS[15623] = Fluid3D([7994,7152,7411,7733],0); -ELEMENTS[15624] = Fluid3D([7152,7411,7733,6479],0); -ELEMENTS[15625] = Fluid3D([7994,7152,7733,7641],0); -ELEMENTS[15626] = Fluid3D([7411,7994,7733,8297],0); -ELEMENTS[15627] = Fluid3D([6867,6541,7311,7078],0); -ELEMENTS[15628] = Fluid3D([6867,6541,7078,6050],0); -ELEMENTS[15629] = Fluid3D([7409,6897,6563,7129],0); -ELEMENTS[15630] = Fluid3D([6897,6563,7129,6365],0); -ELEMENTS[15631] = Fluid3D([7409,6897,7129,7763],0); -ELEMENTS[15632] = Fluid3D([6563,7409,7129,7363],0); -ELEMENTS[15633] = Fluid3D([7129,6563,7363,6572],0); -ELEMENTS[15634] = Fluid3D([7129,6563,6572,6513],0); -ELEMENTS[15635] = Fluid3D([6572,7129,6513,7396],0); -ELEMENTS[15636] = Fluid3D([7573,7994,8483,7641],0); -ELEMENTS[15637] = Fluid3D([7573,7152,7994,7641],0); -ELEMENTS[15638] = Fluid3D([6631,6867,6936,7520],0); -ELEMENTS[15639] = Fluid3D([6964,7413,7803,7291],0); -ELEMENTS[15640] = Fluid3D([7803,6964,7291,7112],0); -ELEMENTS[15641] = Fluid3D([7803,6964,7112,7079],0); -ELEMENTS[15642] = Fluid3D([6964,7413,7291,6299],0); -ELEMENTS[15643] = Fluid3D([7959,8603,8708,8297],0); -ELEMENTS[15644] = Fluid3D([7079,7482,7520,8056],0); -ELEMENTS[15645] = Fluid3D([8056,7573,8483,7803],0); -ELEMENTS[15646] = Fluid3D([7409,6795,7520,6867],0); -ELEMENTS[15647] = Fluid3D([6541,6936,7311,7096],0); -ELEMENTS[15648] = Fluid3D([6330,6390,6978,6483],0); -ELEMENTS[15649] = Fluid3D([6978,6330,6483,7096],0); -ELEMENTS[15650] = Fluid3D([6330,6483,7096,6097],0); -ELEMENTS[15651] = Fluid3D([6483,6978,7096,7310],0); -ELEMENTS[15652] = Fluid3D([6483,6978,7310,7119],0); -ELEMENTS[15653] = Fluid3D([6978,7096,7310,7776],0); -ELEMENTS[15654] = Fluid3D([7310,6978,7776,8065],0); -ELEMENTS[15655] = Fluid3D([6978,7096,7776,6936],0); -ELEMENTS[15656] = Fluid3D([5415,5748,6000,5197],0); -ELEMENTS[15657] = Fluid3D([5010,4936,5205,5545],0); -ELEMENTS[15658] = Fluid3D([4964,4570,5106,4742],0); -ELEMENTS[15659] = Fluid3D([4936,4622,5205,4747],0); -ELEMENTS[15660] = Fluid3D([5205,4622,4964,4833],0); -ELEMENTS[15661] = Fluid3D([4964,5205,4833,5466],0); -ELEMENTS[15662] = Fluid3D([5205,4622,4833,4747],0); -ELEMENTS[15663] = Fluid3D([4622,4964,4833,4437],0); -ELEMENTS[15664] = Fluid3D([4964,4833,4437,4910],0); -ELEMENTS[15665] = Fluid3D([4622,4964,4437,4570],0); -ELEMENTS[15666] = Fluid3D([4437,4964,4910,4546],0); -ELEMENTS[15667] = Fluid3D([4964,4910,4546,5466],0); -ELEMENTS[15668] = Fluid3D([4964,4910,5466,4833],0); -ELEMENTS[15669] = Fluid3D([4833,4622,4437,4312],0); -ELEMENTS[15670] = Fluid3D([4437,4833,4312,4440],0); -ELEMENTS[15671] = Fluid3D([4437,4833,4440,4910],0); -ELEMENTS[15672] = Fluid3D([4833,4622,4312,4747],0); -ELEMENTS[15673] = Fluid3D([4437,4964,4546,4570],0); -ELEMENTS[15674] = Fluid3D([4622,4437,4312,3995],0); -ELEMENTS[15675] = Fluid3D([4833,4312,4440,4609],0); -ELEMENTS[15676] = Fluid3D([4833,4312,4609,4747],0); -ELEMENTS[15677] = Fluid3D([4312,4440,4609,4066],0); -ELEMENTS[15678] = Fluid3D([4609,4312,4066,4330],0); -ELEMENTS[15679] = Fluid3D([4312,4440,4066,3961],0); -ELEMENTS[15680] = Fluid3D([4440,4066,3961,4009],0); -ELEMENTS[15681] = Fluid3D([3961,4440,4009,4437],0); -ELEMENTS[15682] = Fluid3D([4312,4440,3961,4437],0); -ELEMENTS[15683] = Fluid3D([4440,4833,4609,4963],0); -ELEMENTS[15684] = Fluid3D([4440,4833,4963,4910],0); -ELEMENTS[15685] = Fluid3D([4833,4609,4963,5188],0); -ELEMENTS[15686] = Fluid3D([4609,4440,4963,4410],0); -ELEMENTS[15687] = Fluid3D([4609,4963,5188,4998],0); -ELEMENTS[15688] = Fluid3D([4963,5188,4998,5523],0); -ELEMENTS[15689] = Fluid3D([4963,5188,5523,5804],0); -ELEMENTS[15690] = Fluid3D([4609,4963,4998,4410],0); -ELEMENTS[15691] = Fluid3D([4833,4609,5188,4747],0); -ELEMENTS[15692] = Fluid3D([4963,4833,5188,5403],0); -ELEMENTS[15693] = Fluid3D([4963,4833,5403,4910],0); -ELEMENTS[15694] = Fluid3D([4833,5188,5403,5205],0); -ELEMENTS[15695] = Fluid3D([5188,4963,5403,5804],0); -ELEMENTS[15696] = Fluid3D([4440,4609,4066,4410],0); -ELEMENTS[15697] = Fluid3D([4066,4440,4410,4009],0); -ELEMENTS[15698] = Fluid3D([4440,4410,4009,4368],0); -ELEMENTS[15699] = Fluid3D([4910,4437,4546,4443],0); -ELEMENTS[15700] = Fluid3D([4437,4546,4443,4112],0); -ELEMENTS[15701] = Fluid3D([4546,4910,4443,4863],0); -ELEMENTS[15702] = Fluid3D([4546,4910,4863,5244],0); -ELEMENTS[15703] = Fluid3D([4443,4546,4863,4414],0); -ELEMENTS[15704] = Fluid3D([4443,4546,4414,4106],0); -ELEMENTS[15705] = Fluid3D([4443,4546,4106,4112],0); -ELEMENTS[15706] = Fluid3D([4910,4437,4443,4440],0); -ELEMENTS[15707] = Fluid3D([4546,4910,5244,5466],0); -ELEMENTS[15708] = Fluid3D([4910,5244,5466,5613],0); -ELEMENTS[15709] = Fluid3D([5244,5466,5613,5717],0); -ELEMENTS[15710] = Fluid3D([5244,5466,5717,5455],0); -ELEMENTS[15711] = Fluid3D([5717,5244,5455,5612],0); -ELEMENTS[15712] = Fluid3D([5244,5466,5455,5106],0); -ELEMENTS[15713] = Fluid3D([5613,5244,5717,5449],0); -ELEMENTS[15714] = Fluid3D([5244,5717,5449,5612],0); -ELEMENTS[15715] = Fluid3D([5466,5717,5455,6097],0); -ELEMENTS[15716] = Fluid3D([5717,5613,5449,6181],0); -ELEMENTS[15717] = Fluid3D([5455,5244,5106,5612],0); -ELEMENTS[15718] = Fluid3D([4863,4546,5244,4742],0); -ELEMENTS[15719] = Fluid3D([4910,4443,4863,4719],0); -ELEMENTS[15720] = Fluid3D([4443,4863,4719,4449],0); -ELEMENTS[15721] = Fluid3D([4863,4719,4449,4983],0); -ELEMENTS[15722] = Fluid3D([4863,4719,4983,5613],0); -ELEMENTS[15723] = Fluid3D([4910,4443,4719,4440],0); -ELEMENTS[15724] = Fluid3D([4863,4910,4719,5613],0); -ELEMENTS[15725] = Fluid3D([4443,4863,4449,4414],0); -ELEMENTS[15726] = Fluid3D([4719,4449,4983,4368],0); -ELEMENTS[15727] = Fluid3D([4719,4449,4368,4443],0); -ELEMENTS[15728] = Fluid3D([4910,4863,5244,5613],0); -ELEMENTS[15729] = Fluid3D([4066,4312,3961,3785],0); -ELEMENTS[15730] = Fluid3D([3961,4066,3785,3599],0); -ELEMENTS[15731] = Fluid3D([4066,4312,3785,4330],0); -ELEMENTS[15732] = Fluid3D([3785,3961,3599,3538],0); -ELEMENTS[15733] = Fluid3D([3961,3599,3538,3542],0); -ELEMENTS[15734] = Fluid3D([3961,3599,3542,4009],0); -ELEMENTS[15735] = Fluid3D([3542,3961,4009,3966],0); -ELEMENTS[15736] = Fluid3D([3961,4009,3966,4437],0); -ELEMENTS[15737] = Fluid3D([3542,3961,3966,3538],0); -ELEMENTS[15738] = Fluid3D([3785,3961,3538,3995],0); -ELEMENTS[15739] = Fluid3D([3961,4066,3599,3864],0); -ELEMENTS[15740] = Fluid3D([4066,3599,3864,3754],0); -ELEMENTS[15741] = Fluid3D([3864,4066,3754,4250],0); -ELEMENTS[15742] = Fluid3D([3599,3864,3754,3583],0); -ELEMENTS[15743] = Fluid3D([3961,4066,3864,4009],0); -ELEMENTS[15744] = Fluid3D([3599,3961,3864,4009],0); -ELEMENTS[15745] = Fluid3D([4066,3599,3754,3798],0); -ELEMENTS[15746] = Fluid3D([4066,3864,4009,4410],0); -ELEMENTS[15747] = Fluid3D([4066,3864,4410,4250],0); -ELEMENTS[15748] = Fluid3D([3754,4066,3798,4074],0); -ELEMENTS[15749] = Fluid3D([3754,4066,4074,4250],0); -ELEMENTS[15750] = Fluid3D([3599,3754,3798,3415],0); -ELEMENTS[15751] = Fluid3D([3599,3754,3415,3411],0); -ELEMENTS[15752] = Fluid3D([3599,3754,3411,3583],0); -ELEMENTS[15753] = Fluid3D([3798,3754,4074,3672],0); -ELEMENTS[15754] = Fluid3D([3754,3415,3411,3334],0); -ELEMENTS[15755] = Fluid3D([4066,3599,3798,3785],0); -ELEMENTS[15756] = Fluid3D([3798,4066,3785,4330],0); -ELEMENTS[15757] = Fluid3D([3599,3798,3785,3573],0); -ELEMENTS[15758] = Fluid3D([3798,3785,3573,3899],0); -ELEMENTS[15759] = Fluid3D([3798,3785,3899,4330],0); -ELEMENTS[15760] = Fluid3D([3785,3573,3899,3995],0); -ELEMENTS[15761] = Fluid3D([3573,3798,3899,3816],0); -ELEMENTS[15762] = Fluid3D([3785,3599,3573,3538],0); -ELEMENTS[15763] = Fluid3D([3573,3785,3538,3564],0); -ELEMENTS[15764] = Fluid3D([3538,3573,3564,3114],0); -ELEMENTS[15765] = Fluid3D([3785,3538,3564,3995],0); -ELEMENTS[15766] = Fluid3D([3538,3564,3995,3659],0); -ELEMENTS[15767] = Fluid3D([3538,3564,3659,3357],0); -ELEMENTS[15768] = Fluid3D([3538,3564,3357,3114],0); -ELEMENTS[15769] = Fluid3D([3573,3785,3564,3995],0); -ELEMENTS[15770] = Fluid3D([3599,3798,3573,3415],0); -ELEMENTS[15771] = Fluid3D([3798,3573,3415,3672],0); -ELEMENTS[15772] = Fluid3D([3564,3659,3357,3420],0); -ELEMENTS[15773] = Fluid3D([3564,3995,3659,3782],0); -ELEMENTS[15774] = Fluid3D([3659,3538,3357,3542],0); -ELEMENTS[15775] = Fluid3D([3798,3899,3816,4330],0); -ELEMENTS[15776] = Fluid3D([4074,3798,3672,3816],0); -ELEMENTS[15777] = Fluid3D([3672,4074,3816,4053],0); -ELEMENTS[15778] = Fluid3D([3816,3672,4053,3555],0); -ELEMENTS[15779] = Fluid3D([3816,3672,3555,3424],0); -ELEMENTS[15780] = Fluid3D([3816,3672,3424,3573],0); -ELEMENTS[15781] = Fluid3D([3672,3555,3424,3215],0); -ELEMENTS[15782] = Fluid3D([3672,4053,3555,3546],0); -ELEMENTS[15783] = Fluid3D([3555,3816,3424,3688],0); -ELEMENTS[15784] = Fluid3D([3798,3672,3816,3573],0); -ELEMENTS[15785] = Fluid3D([3672,3555,3215,3546],0); -ELEMENTS[15786] = Fluid3D([3424,3672,3215,3415],0); -ELEMENTS[15787] = Fluid3D([4053,3816,3555,4463],0); -ELEMENTS[15788] = Fluid3D([3672,4074,4053,3905],0); -ELEMENTS[15789] = Fluid3D([3555,3424,3215,3221],0); -ELEMENTS[15790] = Fluid3D([3424,3215,3221,3043],0); -ELEMENTS[15791] = Fluid3D([3424,3215,3043,3415],0); -ELEMENTS[15792] = Fluid3D([3215,3221,3043,2927],0); -ELEMENTS[15793] = Fluid3D([3754,3798,3415,3672],0); -ELEMENTS[15794] = Fluid3D([3754,4074,3672,3905],0); -ELEMENTS[15795] = Fluid3D([4066,3798,4074,4330],0); -ELEMENTS[15796] = Fluid3D([3415,3599,3411,3244],0); -ELEMENTS[15797] = Fluid3D([3599,3411,3244,3492],0); -ELEMENTS[15798] = Fluid3D([3415,3599,3244,3573],0); -ELEMENTS[15799] = Fluid3D([3244,3599,3492,3542],0); -ELEMENTS[15800] = Fluid3D([3599,3492,3542,3864],0); -ELEMENTS[15801] = Fluid3D([3599,3492,3864,3583],0); -ELEMENTS[15802] = Fluid3D([3599,3411,3492,3583],0); -ELEMENTS[15803] = Fluid3D([3411,3492,3583,3197],0); -ELEMENTS[15804] = Fluid3D([3583,3411,3197,3057],0); -ELEMENTS[15805] = Fluid3D([3411,3492,3197,3244],0); -ELEMENTS[15806] = Fluid3D([3215,3555,3221,3313],0); -ELEMENTS[15807] = Fluid3D([3221,3043,2927,2860],0); -ELEMENTS[15808] = Fluid3D([3555,3424,3221,3688],0); -ELEMENTS[15809] = Fluid3D([3599,3573,3538,3244],0); -ELEMENTS[15810] = Fluid3D([3411,3415,3244,3037],0); -ELEMENTS[15811] = Fluid3D([3244,3411,3037,3197],0); -ELEMENTS[15812] = Fluid3D([3415,3244,3037,2854],0); -ELEMENTS[15813] = Fluid3D([3411,3415,3037,3334],0); -ELEMENTS[15814] = Fluid3D([3221,3424,3043,3203],0); -ELEMENTS[15815] = Fluid3D([3043,3221,3203,2860],0); -ELEMENTS[15816] = Fluid3D([3221,3424,3203,3688],0); -ELEMENTS[15817] = Fluid3D([3221,3203,2860,3156],0); -ELEMENTS[15818] = Fluid3D([3221,3203,3156,3688],0); -ELEMENTS[15819] = Fluid3D([3424,3043,3203,3125],0); -ELEMENTS[15820] = Fluid3D([3043,3203,3125,2841],0); -ELEMENTS[15821] = Fluid3D([3125,3043,2841,2854],0); -ELEMENTS[15822] = Fluid3D([3424,3043,3125,3415],0); -ELEMENTS[15823] = Fluid3D([3043,3203,2841,2860],0); -ELEMENTS[15824] = Fluid3D([3203,3424,3125,3515],0); -ELEMENTS[15825] = Fluid3D([3424,3125,3515,3573],0); -ELEMENTS[15826] = Fluid3D([3203,3424,3515,3688],0); -ELEMENTS[15827] = Fluid3D([3125,3043,2854,3415],0); -ELEMENTS[15828] = Fluid3D([3203,2860,3156,2963],0); -ELEMENTS[15829] = Fluid3D([2841,3043,2860,2670],0); -ELEMENTS[15830] = Fluid3D([2841,3043,2670,2854],0); -ELEMENTS[15831] = Fluid3D([3203,2841,2860,2963],0); -ELEMENTS[15832] = Fluid3D([2860,3221,3156,3009],0); -ELEMENTS[15833] = Fluid3D([3221,3156,3009,3440],0); -ELEMENTS[15834] = Fluid3D([2860,2841,2670,2572],0); -ELEMENTS[15835] = Fluid3D([2841,2670,2572,2517],0); -ELEMENTS[15836] = Fluid3D([2841,2670,2517,2854],0); -ELEMENTS[15837] = Fluid3D([2860,2841,2572,2963],0); -ELEMENTS[15838] = Fluid3D([2572,2841,2517,2858],0); -ELEMENTS[15839] = Fluid3D([3043,2860,2670,2927],0); -ELEMENTS[15840] = Fluid3D([2670,2572,2517,2372],0); -ELEMENTS[15841] = Fluid3D([2517,2670,2372,2475],0); -ELEMENTS[15842] = Fluid3D([2517,2670,2475,2854],0); -ELEMENTS[15843] = Fluid3D([2860,3221,3009,2927],0); -ELEMENTS[15844] = Fluid3D([2670,2572,2372,2538],0); -ELEMENTS[15845] = Fluid3D([2372,2517,2475,2269],0); -ELEMENTS[15846] = Fluid3D([2572,2517,2372,2337],0); -ELEMENTS[15847] = Fluid3D([2572,2517,2337,2614],0); -ELEMENTS[15848] = Fluid3D([2572,2517,2614,2858],0); -ELEMENTS[15849] = Fluid3D([2670,2860,2572,2538],0); -ELEMENTS[15850] = Fluid3D([2517,2614,2858,2546],0); -ELEMENTS[15851] = Fluid3D([2614,2858,2546,2746],0); -ELEMENTS[15852] = Fluid3D([2614,2858,2746,2750],0); -ELEMENTS[15853] = Fluid3D([2614,2858,2750,2963],0); -ELEMENTS[15854] = Fluid3D([2858,2746,2750,3222],0); -ELEMENTS[15855] = Fluid3D([2858,2546,2746,3108],0); -ELEMENTS[15856] = Fluid3D([2546,2614,2746,2438],0); -ELEMENTS[15857] = Fluid3D([2546,2614,2438,2337],0); -ELEMENTS[15858] = Fluid3D([2614,2858,2963,2572],0); -ELEMENTS[15859] = Fluid3D([2746,2546,2438,2522],0); -ELEMENTS[15860] = Fluid3D([2746,2546,2522,2774],0); -ELEMENTS[15861] = Fluid3D([2522,2746,2774,2716],0); -ELEMENTS[15862] = Fluid3D([2774,2522,2716,2592],0); -ELEMENTS[15863] = Fluid3D([2774,2522,2592,2536],0); -ELEMENTS[15864] = Fluid3D([2774,2522,2536,2626],0); -ELEMENTS[15865] = Fluid3D([2774,2522,2626,2546],0); -ELEMENTS[15866] = Fluid3D([2522,2626,2546,2353],0); -ELEMENTS[15867] = Fluid3D([2626,2546,2353,2495],0); -ELEMENTS[15868] = Fluid3D([2626,2546,2495,2899],0); -ELEMENTS[15869] = Fluid3D([2353,2626,2495,2485],0); -ELEMENTS[15870] = Fluid3D([2546,2353,2495,2294],0); -ELEMENTS[15871] = Fluid3D([2626,2495,2485,2749],0); -ELEMENTS[15872] = Fluid3D([2353,2626,2485,2536],0); -ELEMENTS[15873] = Fluid3D([2495,2546,2294,2517],0); -ELEMENTS[15874] = Fluid3D([2546,2353,2294,2438],0); -ELEMENTS[15875] = Fluid3D([2522,2626,2353,2536],0); -ELEMENTS[15876] = Fluid3D([2522,2592,2536,2311],0); -ELEMENTS[15877] = Fluid3D([2536,2774,2626,2817],0); -ELEMENTS[15878] = Fluid3D([2546,2438,2522,2353],0); -ELEMENTS[15879] = Fluid3D([2522,2592,2311,2404],0); -ELEMENTS[15880] = Fluid3D([2774,2626,2817,3064],0); -ELEMENTS[15881] = Fluid3D([2522,2592,2404,2716],0); -ELEMENTS[15882] = Fluid3D([2592,2774,2536,2794],0); -ELEMENTS[15883] = Fluid3D([2536,2522,2311,2353],0); -ELEMENTS[15884] = Fluid3D([2536,2774,2817,2794],0); -ELEMENTS[15885] = Fluid3D([2592,2774,2794,2946],0); -ELEMENTS[15886] = Fluid3D([2858,2750,2963,3222],0); -ELEMENTS[15887] = Fluid3D([2311,2522,2404,2258],0); -ELEMENTS[15888] = Fluid3D([2522,2746,2716,2557],0); -ELEMENTS[15889] = Fluid3D([2311,2522,2258,2353],0); -ELEMENTS[15890] = Fluid3D([2716,2774,2592,2946],0); -ELEMENTS[15891] = Fluid3D([2746,2614,2750,2438],0); -ELEMENTS[15892] = Fluid3D([2592,2536,2311,2432],0); -ELEMENTS[15893] = Fluid3D([2536,2311,2432,2275],0); -ELEMENTS[15894] = Fluid3D([2536,2311,2275,2353],0); -ELEMENTS[15895] = Fluid3D([2536,2592,2794,2432],0); -ELEMENTS[15896] = Fluid3D([2311,2432,2275,2171],0); -ELEMENTS[15897] = Fluid3D([2311,2432,2171,2326],0); -ELEMENTS[15898] = Fluid3D([2311,2432,2326,2592],0); -ELEMENTS[15899] = Fluid3D([2592,2311,2404,2326],0); -ELEMENTS[15900] = Fluid3D([2353,2495,2294,2223],0); -ELEMENTS[15901] = Fluid3D([2495,2294,2223,2269],0); -ELEMENTS[15902] = Fluid3D([2294,2223,2269,2081],0); -ELEMENTS[15903] = Fluid3D([2269,2294,2081,2337],0); -ELEMENTS[15904] = Fluid3D([2269,2294,2337,2517],0); -ELEMENTS[15905] = Fluid3D([2269,2294,2517,2495],0); -ELEMENTS[15906] = Fluid3D([2294,2337,2517,2546],0); -ELEMENTS[15907] = Fluid3D([2294,2223,2081,2157],0); -ELEMENTS[15908] = Fluid3D([2081,2294,2157,2143],0); -ELEMENTS[15909] = Fluid3D([2081,2294,2143,2337],0); -ELEMENTS[15910] = Fluid3D([2294,2143,2337,2438],0); -ELEMENTS[15911] = Fluid3D([2294,2157,2143,2258],0); -ELEMENTS[15912] = Fluid3D([2157,2081,2143,1977],0); -ELEMENTS[15913] = Fluid3D([2294,2353,2223,2157],0); -ELEMENTS[15914] = Fluid3D([2294,2353,2157,2258],0); -ELEMENTS[15915] = Fluid3D([2353,2223,2157,2185],0); -ELEMENTS[15916] = Fluid3D([2157,2353,2185,2311],0); -ELEMENTS[15917] = Fluid3D([2353,2157,2258,2311],0); -ELEMENTS[15918] = Fluid3D([2353,2223,2185,2485],0); -ELEMENTS[15919] = Fluid3D([2157,2081,1977,1997],0); -ELEMENTS[15920] = Fluid3D([2081,1977,1997,1888],0); -ELEMENTS[15921] = Fluid3D([2081,1977,1888,1966],0); -ELEMENTS[15922] = Fluid3D([2081,1977,1966,2143],0); -ELEMENTS[15923] = Fluid3D([2157,2081,1997,2223],0); -ELEMENTS[15924] = Fluid3D([2404,2311,2258,2152],0); -ELEMENTS[15925] = Fluid3D([2311,2258,2152,2083],0); -ELEMENTS[15926] = Fluid3D([2311,2258,2083,2157],0); -ELEMENTS[15927] = Fluid3D([2258,2083,2157,1977],0); -ELEMENTS[15928] = Fluid3D([2083,2157,1977,1997],0); -ELEMENTS[15929] = Fluid3D([1997,2081,1888,2018],0); -ELEMENTS[15930] = Fluid3D([1997,2081,2018,2223],0); -ELEMENTS[15931] = Fluid3D([2522,2404,2258,2438],0); -ELEMENTS[15932] = Fluid3D([2258,2522,2438,2353],0); -ELEMENTS[15933] = Fluid3D([2495,2353,2485,2223],0); -ELEMENTS[15934] = Fluid3D([2626,2536,2817,2485],0); -ELEMENTS[15935] = Fluid3D([2626,2495,2749,2899],0); -ELEMENTS[15936] = Fluid3D([2404,2522,2716,2557],0); -ELEMENTS[15937] = Fluid3D([2517,2614,2546,2337],0); -ELEMENTS[15938] = Fluid3D([2438,2746,2522,2557],0); -ELEMENTS[15939] = Fluid3D([2438,2746,2557,2750],0); -ELEMENTS[15940] = Fluid3D([2557,2438,2750,2436],0); -ELEMENTS[15941] = Fluid3D([2557,2438,2436,2289],0); -ELEMENTS[15942] = Fluid3D([2557,2438,2289,2404],0); -ELEMENTS[15943] = Fluid3D([2436,2557,2289,2474],0); -ELEMENTS[15944] = Fluid3D([2436,2557,2474,2722],0); -ELEMENTS[15945] = Fluid3D([2436,2557,2722,2750],0); -ELEMENTS[15946] = Fluid3D([2557,2722,2750,2885],0); -ELEMENTS[15947] = Fluid3D([2722,2750,2885,3157],0); -ELEMENTS[15948] = Fluid3D([2722,2436,2750,2801],0); -ELEMENTS[15949] = Fluid3D([2750,2722,2801,3157],0); -ELEMENTS[15950] = Fluid3D([2557,2289,2474,2467],0); -ELEMENTS[15951] = Fluid3D([2557,2289,2467,2404],0); -ELEMENTS[15952] = Fluid3D([2289,2467,2404,2222],0); -ELEMENTS[15953] = Fluid3D([2467,2404,2222,2422],0); -ELEMENTS[15954] = Fluid3D([2467,2404,2422,2739],0); -ELEMENTS[15955] = Fluid3D([2222,2467,2422,2373],0); -ELEMENTS[15956] = Fluid3D([2222,2467,2373,2291],0); -ELEMENTS[15957] = Fluid3D([2222,2467,2291,2289],0); -ELEMENTS[15958] = Fluid3D([2467,2291,2289,2474],0); -ELEMENTS[15959] = Fluid3D([2291,2289,2474,2243],0); -ELEMENTS[15960] = Fluid3D([2474,2291,2243,2245],0); -ELEMENTS[15961] = Fluid3D([2467,2291,2474,2523],0); -ELEMENTS[15962] = Fluid3D([2291,2474,2523,2414],0); -ELEMENTS[15963] = Fluid3D([2291,2474,2414,2245],0); -ELEMENTS[15964] = Fluid3D([2291,2289,2243,2092],0); -ELEMENTS[15965] = Fluid3D([2291,2289,2092,2222],0); -ELEMENTS[15966] = Fluid3D([2243,2291,2092,2066],0); -ELEMENTS[15967] = Fluid3D([2523,2291,2414,2229],0); -ELEMENTS[15968] = Fluid3D([2474,2523,2414,2666],0); -ELEMENTS[15969] = Fluid3D([2523,2414,2666,2494],0); -ELEMENTS[15970] = Fluid3D([2414,2666,2494,2442],0); -ELEMENTS[15971] = Fluid3D([2666,2523,2494,2768],0); -ELEMENTS[15972] = Fluid3D([2666,2523,2768,2783],0); -ELEMENTS[15973] = Fluid3D([2414,2474,2666,2665],0); -ELEMENTS[15974] = Fluid3D([2494,2666,2768,2776],0); -ELEMENTS[15975] = Fluid3D([2494,2666,2776,2442],0); -ELEMENTS[15976] = Fluid3D([2467,2422,2373,2653],0); -ELEMENTS[15977] = Fluid3D([2467,2422,2653,2739],0); -ELEMENTS[15978] = Fluid3D([2474,2523,2666,2783],0); -ELEMENTS[15979] = Fluid3D([2467,2557,2404,2716],0); -ELEMENTS[15980] = Fluid3D([2404,2467,2716,2739],0); -ELEMENTS[15981] = Fluid3D([2404,2222,2422,2326],0); -ELEMENTS[15982] = Fluid3D([2557,2474,2722,2783],0); -ELEMENTS[15983] = Fluid3D([2467,2291,2523,2373],0); -ELEMENTS[15984] = Fluid3D([2291,2523,2373,2229],0); -ELEMENTS[15985] = Fluid3D([2523,2467,2373,2653],0); -ELEMENTS[15986] = Fluid3D([2373,2523,2653,2566],0); -ELEMENTS[15987] = Fluid3D([2373,2523,2566,2494],0); -ELEMENTS[15988] = Fluid3D([2666,2768,2776,2987],0); -ELEMENTS[15989] = Fluid3D([2666,2768,2987,2783],0); -ELEMENTS[15990] = Fluid3D([2474,2557,2467,2783],0); -ELEMENTS[15991] = Fluid3D([2494,2414,2442,2229],0); -ELEMENTS[15992] = Fluid3D([2494,2414,2229,2523],0); -ELEMENTS[15993] = Fluid3D([2289,2474,2243,2436],0); -ELEMENTS[15994] = Fluid3D([2474,2243,2436,2481],0); -ELEMENTS[15995] = Fluid3D([2474,2243,2481,2245],0); -ELEMENTS[15996] = Fluid3D([2243,2436,2481,2288],0); -ELEMENTS[15997] = Fluid3D([2243,2436,2288,2186],0); -ELEMENTS[15998] = Fluid3D([2243,2436,2186,2289],0); -ELEMENTS[15999] = Fluid3D([2523,2494,2768,2566],0); -ELEMENTS[16000] = Fluid3D([2768,2523,2566,2653],0); -ELEMENTS[16001] = Fluid3D([2481,2243,2288,2276],0); -ELEMENTS[16002] = Fluid3D([2438,2436,2289,2186],0); -ELEMENTS[16003] = Fluid3D([2474,2467,2523,2783],0); -ELEMENTS[16004] = Fluid3D([2653,2373,2566,2482],0); -ELEMENTS[16005] = Fluid3D([2373,2566,2482,2300],0); -ELEMENTS[16006] = Fluid3D([2373,2566,2300,2494],0); -ELEMENTS[16007] = Fluid3D([2482,2373,2300,2214],0); -ELEMENTS[16008] = Fluid3D([2482,2373,2214,2422],0); -ELEMENTS[16009] = Fluid3D([2482,2373,2422,2653],0); -ELEMENTS[16010] = Fluid3D([2422,2482,2653,2739],0); -ELEMENTS[16011] = Fluid3D([2474,2436,2722,2481],0); -ELEMENTS[16012] = Fluid3D([2288,2243,2186,2094],0); -ELEMENTS[16013] = Fluid3D([2373,2300,2214,2041],0); -ELEMENTS[16014] = Fluid3D([2436,2481,2288,2569],0); -ELEMENTS[16015] = Fluid3D([2288,2436,2569,2385],0); -ELEMENTS[16016] = Fluid3D([2288,2436,2385,2186],0); -ELEMENTS[16017] = Fluid3D([2436,2481,2569,2801],0); -ELEMENTS[16018] = Fluid3D([2481,2569,2801,2649],0); -ELEMENTS[16019] = Fluid3D([2569,2801,2649,2859],0); -ELEMENTS[16020] = Fluid3D([2569,2801,2859,2750],0); -ELEMENTS[16021] = Fluid3D([2649,2569,2859,2568],0); -ELEMENTS[16022] = Fluid3D([2649,2569,2568,2288],0); -ELEMENTS[16023] = Fluid3D([2569,2859,2568,2680],0); -ELEMENTS[16024] = Fluid3D([2569,2859,2680,2963],0); -ELEMENTS[16025] = Fluid3D([2801,2649,2859,3050],0); -ELEMENTS[16026] = Fluid3D([2568,2569,2680,2385],0); -ELEMENTS[16027] = Fluid3D([2859,2568,2680,2846],0); -ELEMENTS[16028] = Fluid3D([2481,2569,2649,2288],0); -ELEMENTS[16029] = Fluid3D([2422,2222,2373,2214],0); -ELEMENTS[16030] = Fluid3D([2859,2649,2568,2825],0); -ELEMENTS[16031] = Fluid3D([2649,2568,2825,2509],0); -ELEMENTS[16032] = Fluid3D([2568,2859,2825,2846],0); -ELEMENTS[16033] = Fluid3D([2768,2494,2776,2694],0); -ELEMENTS[16034] = Fluid3D([2494,2776,2694,2662],0); -ELEMENTS[16035] = Fluid3D([2776,2768,2694,3025],0); -ELEMENTS[16036] = Fluid3D([2768,2494,2694,2566],0); -ELEMENTS[16037] = Fluid3D([2776,2768,3025,2987],0); -ELEMENTS[16038] = Fluid3D([2768,3025,2987,3032],0); -ELEMENTS[16039] = Fluid3D([2987,2768,3032,2783],0); -ELEMENTS[16040] = Fluid3D([2768,3025,3032,2637],0); -ELEMENTS[16041] = Fluid3D([2722,2436,2801,2481],0); -ELEMENTS[16042] = Fluid3D([2801,2722,2481,2665],0); -ELEMENTS[16043] = Fluid3D([2801,2722,2665,2865],0); -ELEMENTS[16044] = Fluid3D([2801,2722,2865,3157],0); -ELEMENTS[16045] = Fluid3D([2481,2801,2665,2649],0); -ELEMENTS[16046] = Fluid3D([2665,2481,2649,2469],0); -ELEMENTS[16047] = Fluid3D([2694,2776,3025,2881],0); -ELEMENTS[16048] = Fluid3D([2694,2776,2881,2662],0); -ELEMENTS[16049] = Fluid3D([2776,2881,2662,2938],0); -ELEMENTS[16050] = Fluid3D([2881,2694,2662,2642],0); -ELEMENTS[16051] = Fluid3D([2662,2881,2642,2925],0); -ELEMENTS[16052] = Fluid3D([2662,2881,2925,2938],0); -ELEMENTS[16053] = Fluid3D([2881,2642,2925,2936],0); -ELEMENTS[16054] = Fluid3D([2925,2881,2936,3367],0); -ELEMENTS[16055] = Fluid3D([2925,2881,3367,2938],0); -ELEMENTS[16056] = Fluid3D([2881,2936,3367,3025],0); -ELEMENTS[16057] = Fluid3D([2936,2925,3367,3204],0); -ELEMENTS[16058] = Fluid3D([2881,2694,2642,2936],0); -ELEMENTS[16059] = Fluid3D([2569,2288,2385,2568],0); -ELEMENTS[16060] = Fluid3D([2442,2494,2229,2417],0); -ELEMENTS[16061] = Fluid3D([2442,2494,2417,2662],0); -ELEMENTS[16062] = Fluid3D([2494,2229,2417,2215],0); -ELEMENTS[16063] = Fluid3D([2557,2722,2885,2783],0); -ELEMENTS[16064] = Fluid3D([2289,2243,2092,2186],0); -ELEMENTS[16065] = Fluid3D([2436,2569,2385,2750],0); -ELEMENTS[16066] = Fluid3D([2373,2222,2291,2134],0); -ELEMENTS[16067] = Fluid3D([2222,2291,2134,2092],0); -ELEMENTS[16068] = Fluid3D([2373,2222,2134,2214],0); -ELEMENTS[16069] = Fluid3D([2291,2373,2134,2229],0); -ELEMENTS[16070] = Fluid3D([2566,2482,2300,2464],0); -ELEMENTS[16071] = Fluid3D([2680,2859,2846,3156],0); -ELEMENTS[16072] = Fluid3D([2746,2858,3108,3222],0); -ELEMENTS[16073] = Fluid3D([2523,2467,2653,2783],0); -ELEMENTS[16074] = Fluid3D([2467,2653,2783,2739],0); -ELEMENTS[16075] = Fluid3D([2653,2783,2739,3116],0); -ELEMENTS[16076] = Fluid3D([2653,2523,2783,2768],0); -ELEMENTS[16077] = Fluid3D([2653,2783,3116,3032],0); -ELEMENTS[16078] = Fluid3D([2522,2438,2557,2404],0); -ELEMENTS[16079] = Fluid3D([2670,2372,2475,2465],0); -ELEMENTS[16080] = Fluid3D([2670,2372,2465,2538],0); -ELEMENTS[16081] = Fluid3D([2475,2670,2465,2705],0); -ELEMENTS[16082] = Fluid3D([2475,2670,2705,2854],0); -ELEMENTS[16083] = Fluid3D([2372,2475,2465,2234],0); -ELEMENTS[16084] = Fluid3D([2475,2465,2234,2406],0); -ELEMENTS[16085] = Fluid3D([2475,2465,2406,2705],0); -ELEMENTS[16086] = Fluid3D([2372,2475,2234,2269],0); -ELEMENTS[16087] = Fluid3D([4312,3961,3785,3995],0); -ELEMENTS[16088] = Fluid3D([2774,2817,2794,3223],0); -ELEMENTS[16089] = Fluid3D([3215,3221,2927,3313],0); -ELEMENTS[16090] = Fluid3D([3043,3215,2927,2705],0); -ELEMENTS[16091] = Fluid3D([6227,5484,6052,5826],0); -ELEMENTS[16092] = Fluid3D([6052,6227,5826,6742],0); -ELEMENTS[16093] = Fluid3D([5484,6052,5826,5509],0); -ELEMENTS[16094] = Fluid3D([6052,5826,5509,6044],0); -ELEMENTS[16095] = Fluid3D([6227,5826,6742,6389],0); -ELEMENTS[16096] = Fluid3D([6227,5826,6389,5732],0); -ELEMENTS[16097] = Fluid3D([5826,6389,5732,5914],0); -ELEMENTS[16098] = Fluid3D([6389,5732,5914,6215],0); -ELEMENTS[16099] = Fluid3D([5732,5826,5914,5391],0); -ELEMENTS[16100] = Fluid3D([5732,5826,5391,5248],0); -ELEMENTS[16101] = Fluid3D([5732,5826,5248,5484],0); -ELEMENTS[16102] = Fluid3D([5826,5248,5484,5509],0); -ELEMENTS[16103] = Fluid3D([5914,5732,5391,5609],0); -ELEMENTS[16104] = Fluid3D([5914,5732,5609,6215],0); -ELEMENTS[16105] = Fluid3D([5391,5732,5248,5132],0); -ELEMENTS[16106] = Fluid3D([5732,5391,5609,5132],0); -ELEMENTS[16107] = Fluid3D([5732,5248,5132,5184],0); -ELEMENTS[16108] = Fluid3D([5248,5132,5184,4858],0); -ELEMENTS[16109] = Fluid3D([5184,5248,4858,5128],0); -ELEMENTS[16110] = Fluid3D([5248,4858,5128,5484],0); -ELEMENTS[16111] = Fluid3D([5248,4858,5484,5509],0); -ELEMENTS[16112] = Fluid3D([5184,5248,5128,5484],0); -ELEMENTS[16113] = Fluid3D([5826,5391,5248,5509],0); -ELEMENTS[16114] = Fluid3D([5609,5732,5132,5416],0); -ELEMENTS[16115] = Fluid3D([5132,5609,5416,5044],0); -ELEMENTS[16116] = Fluid3D([5609,5416,5044,5392],0); -ELEMENTS[16117] = Fluid3D([5416,5044,5392,5108],0); -ELEMENTS[16118] = Fluid3D([5609,5416,5392,6030],0); -ELEMENTS[16119] = Fluid3D([5044,5609,5392,5398],0); -ELEMENTS[16120] = Fluid3D([5392,5044,5398,5112],0); -ELEMENTS[16121] = Fluid3D([5392,5044,5112,4542],0); -ELEMENTS[16122] = Fluid3D([5044,5398,5112,4771],0); -ELEMENTS[16123] = Fluid3D([5044,5398,4771,5210],0); -ELEMENTS[16124] = Fluid3D([5044,5398,5210,5609],0); -ELEMENTS[16125] = Fluid3D([5210,5044,5609,5132],0); -ELEMENTS[16126] = Fluid3D([5398,5210,5609,5818],0); -ELEMENTS[16127] = Fluid3D([5210,5609,5818,5391],0); -ELEMENTS[16128] = Fluid3D([5210,5609,5391,5132],0); -ELEMENTS[16129] = Fluid3D([5112,5044,4771,4521],0); -ELEMENTS[16130] = Fluid3D([5112,5044,4521,4542],0); -ELEMENTS[16131] = Fluid3D([4771,5044,5210,4668],0); -ELEMENTS[16132] = Fluid3D([4771,5044,4668,4521],0); -ELEMENTS[16133] = Fluid3D([5826,5914,5391,6044],0); -ELEMENTS[16134] = Fluid3D([5416,5132,5044,4901],0); -ELEMENTS[16135] = Fluid3D([5044,5416,4901,5108],0); -ELEMENTS[16136] = Fluid3D([5826,6389,5914,6742],0); -ELEMENTS[16137] = Fluid3D([5398,5210,5818,5277],0); -ELEMENTS[16138] = Fluid3D([5210,5818,5277,5418],0); -ELEMENTS[16139] = Fluid3D([5210,5818,5418,5391],0); -ELEMENTS[16140] = Fluid3D([5416,5132,4901,5682],0); -ELEMENTS[16141] = Fluid3D([5277,5210,5418,4740],0); -ELEMENTS[16142] = Fluid3D([5398,5392,5112,5690],0); -ELEMENTS[16143] = Fluid3D([5277,5210,4740,4771],0); -ELEMENTS[16144] = Fluid3D([5398,5210,5277,4771],0); -ELEMENTS[16145] = Fluid3D([5044,5210,4668,5132],0); -ELEMENTS[16146] = Fluid3D([6389,5732,6215,6243],0); -ELEMENTS[16147] = Fluid3D([6389,5732,6243,6227],0); -ELEMENTS[16148] = Fluid3D([6243,6389,6227,6969],0); -ELEMENTS[16149] = Fluid3D([6243,6389,6969,6900],0); -ELEMENTS[16150] = Fluid3D([6215,6389,6243,6900],0); -ELEMENTS[16151] = Fluid3D([6227,6243,6969,6458],0); -ELEMENTS[16152] = Fluid3D([6389,6227,6969,6742],0); -ELEMENTS[16153] = Fluid3D([5210,5418,4740,4852],0); -ELEMENTS[16154] = Fluid3D([5210,5418,4852,5391],0); -ELEMENTS[16155] = Fluid3D([4852,5210,5391,4668],0); -ELEMENTS[16156] = Fluid3D([5391,5914,5609,5818],0); -ELEMENTS[16157] = Fluid3D([5210,4771,4668,4740],0); -ELEMENTS[16158] = Fluid3D([5418,4740,4852,5022],0); -ELEMENTS[16159] = Fluid3D([4852,5418,5022,5476],0); -ELEMENTS[16160] = Fluid3D([4852,5418,5476,5391],0); -ELEMENTS[16161] = Fluid3D([4771,5112,4521,4369],0); -ELEMENTS[16162] = Fluid3D([5044,4668,4521,4683],0); -ELEMENTS[16163] = Fluid3D([4521,5044,4683,4542],0); -ELEMENTS[16164] = Fluid3D([4683,4521,4542,4129],0); -ELEMENTS[16165] = Fluid3D([5044,4668,4683,5132],0); -ELEMENTS[16166] = Fluid3D([4683,5044,5132,4901],0); -ELEMENTS[16167] = Fluid3D([5132,4683,4901,4811],0); -ELEMENTS[16168] = Fluid3D([4683,5044,4901,4542],0); -ELEMENTS[16169] = Fluid3D([4901,4683,4542,4811],0); -ELEMENTS[16170] = Fluid3D([4740,5210,4852,4668],0); -ELEMENTS[16171] = Fluid3D([5248,5391,5132,4801],0); -ELEMENTS[16172] = Fluid3D([5391,5132,4801,4668],0); -ELEMENTS[16173] = Fluid3D([5132,5248,4801,4858],0); -ELEMENTS[16174] = Fluid3D([5248,4801,4858,5509],0); -ELEMENTS[16175] = Fluid3D([5398,5112,4771,5076],0); -ELEMENTS[16176] = Fluid3D([4771,5398,5076,5277],0); -ELEMENTS[16177] = Fluid3D([5112,4771,5076,4369],0); -ELEMENTS[16178] = Fluid3D([5818,5277,5418,5810],0); -ELEMENTS[16179] = Fluid3D([5418,5818,5810,6087],0); -ELEMENTS[16180] = Fluid3D([5818,5277,5810,5828],0); -ELEMENTS[16181] = Fluid3D([5818,5277,5828,5398],0); -ELEMENTS[16182] = Fluid3D([5810,5418,6087,5761],0); -ELEMENTS[16183] = Fluid3D([5418,6087,5761,5476],0); -ELEMENTS[16184] = Fluid3D([5810,5418,5761,5251],0); -ELEMENTS[16185] = Fluid3D([5810,5418,5251,5277],0); -ELEMENTS[16186] = Fluid3D([5418,5818,6087,5914],0); -ELEMENTS[16187] = Fluid3D([5818,5810,6087,6394],0); -ELEMENTS[16188] = Fluid3D([5818,5810,6394,5828],0); -ELEMENTS[16189] = Fluid3D([6087,5818,6394,6371],0); -ELEMENTS[16190] = Fluid3D([6087,5818,6371,5914],0); -ELEMENTS[16191] = Fluid3D([5818,6371,5914,5609],0); -ELEMENTS[16192] = Fluid3D([6371,6087,5914,6587],0); -ELEMENTS[16193] = Fluid3D([5914,6371,6587,6706],0); -ELEMENTS[16194] = Fluid3D([5914,6371,6706,6222],0); -ELEMENTS[16195] = Fluid3D([5914,6371,6222,5609],0); -ELEMENTS[16196] = Fluid3D([6371,6587,6706,7064],0); -ELEMENTS[16197] = Fluid3D([6371,6706,6222,6971],0); -ELEMENTS[16198] = Fluid3D([6371,6587,7064,6759],0); -ELEMENTS[16199] = Fluid3D([6371,6587,6759,6087],0); -ELEMENTS[16200] = Fluid3D([6759,6371,6087,6394],0); -ELEMENTS[16201] = Fluid3D([6087,6759,6394,6352],0); -ELEMENTS[16202] = Fluid3D([6087,6759,6352,6447],0); -ELEMENTS[16203] = Fluid3D([6087,6759,6447,6587],0); -ELEMENTS[16204] = Fluid3D([6759,6394,6352,7056],0); -ELEMENTS[16205] = Fluid3D([6759,6394,7056,7064],0); -ELEMENTS[16206] = Fluid3D([6759,6371,6394,7064],0); -ELEMENTS[16207] = Fluid3D([6759,6352,6447,7116],0); -ELEMENTS[16208] = Fluid3D([6352,6759,7056,7116],0); -ELEMENTS[16209] = Fluid3D([6759,7056,7116,7640],0); -ELEMENTS[16210] = Fluid3D([7056,7116,7640,7817],0); -ELEMENTS[16211] = Fluid3D([7056,7116,7817,7132],0); -ELEMENTS[16212] = Fluid3D([7056,7116,7132,6352],0); -ELEMENTS[16213] = Fluid3D([6706,6371,7064,6971],0); -ELEMENTS[16214] = Fluid3D([6371,7064,6971,6394],0); -ELEMENTS[16215] = Fluid3D([7064,6706,6971,7622],0); -ELEMENTS[16216] = Fluid3D([6971,7064,7622,7672],0); -ELEMENTS[16217] = Fluid3D([6971,7064,7672,7057],0); -ELEMENTS[16218] = Fluid3D([6971,7064,7057,6394],0); -ELEMENTS[16219] = Fluid3D([6222,6371,6971,6308],0); -ELEMENTS[16220] = Fluid3D([6706,5914,6222,6389],0); -ELEMENTS[16221] = Fluid3D([6706,5914,6389,6742],0); -ELEMENTS[16222] = Fluid3D([6222,6706,6389,6215],0); -ELEMENTS[16223] = Fluid3D([6389,6222,6215,5914],0); -ELEMENTS[16224] = Fluid3D([6389,6706,6742,6969],0); -ELEMENTS[16225] = Fluid3D([6759,7056,7640,7064],0); -ELEMENTS[16226] = Fluid3D([7640,6759,7064,7182],0); -ELEMENTS[16227] = Fluid3D([7064,7640,7182,8029],0); -ELEMENTS[16228] = Fluid3D([7064,7640,8029,7672],0); -ELEMENTS[16229] = Fluid3D([6447,6759,7116,7182],0); -ELEMENTS[16230] = Fluid3D([6222,6371,6308,5818],0); -ELEMENTS[16231] = Fluid3D([6222,5914,5609,6215],0); -ELEMENTS[16232] = Fluid3D([6352,6087,6447,5761],0); -ELEMENTS[16233] = Fluid3D([6389,6706,6969,6900],0); -ELEMENTS[16234] = Fluid3D([7640,7056,7817,7820],0); -ELEMENTS[16235] = Fluid3D([5609,6222,6215,6030],0); -ELEMENTS[16236] = Fluid3D([6222,6215,6030,6679],0); -ELEMENTS[16237] = Fluid3D([6222,6215,6679,6900],0); -ELEMENTS[16238] = Fluid3D([6030,6222,6679,6308],0); -ELEMENTS[16239] = Fluid3D([6030,6222,6308,5609],0); -ELEMENTS[16240] = Fluid3D([7116,6759,7640,7182],0); -ELEMENTS[16241] = Fluid3D([7116,7817,7132,7779],0); -ELEMENTS[16242] = Fluid3D([7817,7056,7132,7706],0); -ELEMENTS[16243] = Fluid3D([7116,7640,7817,7918],0); -ELEMENTS[16244] = Fluid3D([7817,7116,7918,7779],0); -ELEMENTS[16245] = Fluid3D([7064,7672,7057,7056],0); -ELEMENTS[16246] = Fluid3D([6394,6087,6352,5810],0); -ELEMENTS[16247] = Fluid3D([6087,6352,5810,5761],0); -ELEMENTS[16248] = Fluid3D([6352,6394,5810,6286],0); -ELEMENTS[16249] = Fluid3D([5810,6352,6286,5822],0); -ELEMENTS[16250] = Fluid3D([6352,5810,5761,5822],0); -ELEMENTS[16251] = Fluid3D([7182,7064,8029,7215],0); -ELEMENTS[16252] = Fluid3D([6371,6971,6308,6394],0); -ELEMENTS[16253] = Fluid3D([7132,7116,7779,6799],0); -ELEMENTS[16254] = Fluid3D([7132,7116,6799,6352],0); -ELEMENTS[16255] = Fluid3D([7064,7622,7672,8029],0); -ELEMENTS[16256] = Fluid3D([7672,6971,7057,7307],0); -ELEMENTS[16257] = Fluid3D([6971,7057,7307,6308],0); -ELEMENTS[16258] = Fluid3D([7672,6971,7307,7644],0); -ELEMENTS[16259] = Fluid3D([6394,6352,7056,6286],0); -ELEMENTS[16260] = Fluid3D([7116,7640,7918,7182],0); -ELEMENTS[16261] = Fluid3D([7622,6971,7672,7644],0); -ELEMENTS[16262] = Fluid3D([7640,7182,8029,7918],0); -ELEMENTS[16263] = Fluid3D([6587,5914,6706,6742],0); -ELEMENTS[16264] = Fluid3D([7064,8029,7215,7622],0); -ELEMENTS[16265] = Fluid3D([6706,6971,7622,6900],0); -ELEMENTS[16266] = Fluid3D([7182,7064,7215,6587],0); -ELEMENTS[16267] = Fluid3D([7182,7064,6587,6759],0); -ELEMENTS[16268] = Fluid3D([7215,7182,6587,6977],0); -ELEMENTS[16269] = Fluid3D([7182,6587,6977,6447],0); -ELEMENTS[16270] = Fluid3D([6587,7182,6759,6447],0); -ELEMENTS[16271] = Fluid3D([6587,7215,6977,6742],0); -ELEMENTS[16272] = Fluid3D([7064,7215,6587,6706],0); -ELEMENTS[16273] = Fluid3D([7064,7215,6706,7622],0); -ELEMENTS[16274] = Fluid3D([7215,6587,6706,6742],0); -ELEMENTS[16275] = Fluid3D([7215,7182,6977,7754],0); -ELEMENTS[16276] = Fluid3D([7182,6977,7754,7446],0); -ELEMENTS[16277] = Fluid3D([7182,6977,7446,6447],0); -ELEMENTS[16278] = Fluid3D([7116,7779,6799,7236],0); -ELEMENTS[16279] = Fluid3D([7116,7779,7236,7918],0); -ELEMENTS[16280] = Fluid3D([6971,6222,6308,6679],0); -ELEMENTS[16281] = Fluid3D([6971,6222,6679,6706],0); -ELEMENTS[16282] = Fluid3D([6971,7307,7644,6679],0); -ELEMENTS[16283] = Fluid3D([7644,6971,6679,7622],0); -ELEMENTS[16284] = Fluid3D([6977,7754,7446,7443],0); -ELEMENTS[16285] = Fluid3D([7817,7132,7779,7898],0); -ELEMENTS[16286] = Fluid3D([6977,7754,7443,7391],0); -ELEMENTS[16287] = Fluid3D([6977,7754,7391,7215],0); -ELEMENTS[16288] = Fluid3D([7779,7817,7898,8511],0); -ELEMENTS[16289] = Fluid3D([7779,7817,8511,7918],0); -ELEMENTS[16290] = Fluid3D([7898,7779,8511,8683],0); -ELEMENTS[16291] = Fluid3D([7132,7779,7898,7491],0); -ELEMENTS[16292] = Fluid3D([7132,7779,7491,6799],0); -ELEMENTS[16293] = Fluid3D([7779,7898,7491,8162],0); -ELEMENTS[16294] = Fluid3D([7779,7898,8162,8683],0); -ELEMENTS[16295] = Fluid3D([8162,7779,8683,7572],0); -ELEMENTS[16296] = Fluid3D([8683,8162,7572,8220],0); -ELEMENTS[16297] = Fluid3D([8683,8162,8220,9476],0); -ELEMENTS[16298] = Fluid3D([8162,7572,8220,7491],0); -ELEMENTS[16299] = Fluid3D([7572,8683,8220,8398],0); -ELEMENTS[16300] = Fluid3D([8683,8220,8398,9175],0); -ELEMENTS[16301] = Fluid3D([8683,8220,9175,9476],0); -ELEMENTS[16302] = Fluid3D([8220,8398,9175,8640],0); -ELEMENTS[16303] = Fluid3D([8398,8683,9175,9098],0); -ELEMENTS[16304] = Fluid3D([9175,8220,8640,9029],0); -ELEMENTS[16305] = Fluid3D([9175,8220,9029,9476],0); -ELEMENTS[16306] = Fluid3D([8220,8398,8640,7698],0); -ELEMENTS[16307] = Fluid3D([8220,8398,7698,7572],0); -ELEMENTS[16308] = Fluid3D([8162,7779,7572,7491],0); -ELEMENTS[16309] = Fluid3D([8220,8640,9029,8163],0); -ELEMENTS[16310] = Fluid3D([8029,7182,7215,7754],0); -ELEMENTS[16311] = Fluid3D([6352,6447,7116,6799],0); -ELEMENTS[16312] = Fluid3D([7779,6799,7236,7572],0); -ELEMENTS[16313] = Fluid3D([8398,8640,7698,8417],0); -ELEMENTS[16314] = Fluid3D([7640,7817,7918,8479],0); -ELEMENTS[16315] = Fluid3D([7817,7918,8479,8511],0); -ELEMENTS[16316] = Fluid3D([7918,7640,8479,8029],0); -ELEMENTS[16317] = Fluid3D([8640,9175,9029,9886],0); -ELEMENTS[16318] = Fluid3D([7754,7182,7446,7918],0); -ELEMENTS[16319] = Fluid3D([6308,6371,6394,5818],0); -ELEMENTS[16320] = Fluid3D([7443,6977,7391,6766],0); -ELEMENTS[16321] = Fluid3D([7443,6977,6766,6619],0); -ELEMENTS[16322] = Fluid3D([7443,6977,6619,7446],0); -ELEMENTS[16323] = Fluid3D([6977,7391,6766,6742],0); -ELEMENTS[16324] = Fluid3D([7307,7672,7644,8188],0); -ELEMENTS[16325] = Fluid3D([7307,7672,8188,7820],0); -ELEMENTS[16326] = Fluid3D([7672,7644,8188,8789],0); -ELEMENTS[16327] = Fluid3D([8188,7672,8789,8593],0); -ELEMENTS[16328] = Fluid3D([8188,7672,8593,7820],0); -ELEMENTS[16329] = Fluid3D([6394,5810,6286,5828],0); -ELEMENTS[16330] = Fluid3D([8640,8220,7698,7777],0); -ELEMENTS[16331] = Fluid3D([6799,7116,7236,6447],0); -ELEMENTS[16332] = Fluid3D([7057,7672,7307,7820],0); -ELEMENTS[16333] = Fluid3D([5418,4740,5022,5251],0); -ELEMENTS[16334] = Fluid3D([6227,5484,5826,5732],0); -ELEMENTS[16335] = Fluid3D([5732,5248,5184,5628],0); -ELEMENTS[16336] = Fluid3D([5248,5184,5628,5484],0); -ELEMENTS[16337] = Fluid3D([5628,5248,5484,5732],0); -ELEMENTS[16338] = Fluid3D([6052,5826,6044,6742],0); -ELEMENTS[16339] = Fluid3D([5826,5509,6044,5391],0); -ELEMENTS[16340] = Fluid3D([5484,6052,5509,5576],0); -ELEMENTS[16341] = Fluid3D([5248,5391,4801,5509],0); -ELEMENTS[16342] = Fluid3D([6052,6227,6742,6643],0); -ELEMENTS[16343] = Fluid3D([5002,4543,4918,4844],0); -ELEMENTS[16344] = Fluid3D([4543,4918,4844,4481],0); -ELEMENTS[16345] = Fluid3D([4844,4543,4481,4326],0); -ELEMENTS[16346] = Fluid3D([4481,4844,4326,4952],0); -ELEMENTS[16347] = Fluid3D([4481,4844,4952,4918],0); -ELEMENTS[16348] = Fluid3D([4326,4481,4952,4359],0); -ELEMENTS[16349] = Fluid3D([4326,4481,4359,3982],0); -ELEMENTS[16350] = Fluid3D([4326,4481,3982,4543],0); -ELEMENTS[16351] = Fluid3D([4481,4952,4359,4694],0); -ELEMENTS[16352] = Fluid3D([4481,4952,4694,4918],0); -ELEMENTS[16353] = Fluid3D([4481,4359,3982,4249],0); -ELEMENTS[16354] = Fluid3D([4359,4481,4694,4249],0); -ELEMENTS[16355] = Fluid3D([4481,4694,4249,4597],0); -ELEMENTS[16356] = Fluid3D([4694,4249,4597,4483],0); -ELEMENTS[16357] = Fluid3D([4694,4249,4483,4415],0); -ELEMENTS[16358] = Fluid3D([4694,4249,4415,4359],0); -ELEMENTS[16359] = Fluid3D([4597,4694,4483,5091],0); -ELEMENTS[16360] = Fluid3D([4483,4694,4415,4969],0); -ELEMENTS[16361] = Fluid3D([4249,4597,4483,4160],0); -ELEMENTS[16362] = Fluid3D([3982,4481,4249,4143],0); -ELEMENTS[16363] = Fluid3D([4249,4483,4415,3874],0); -ELEMENTS[16364] = Fluid3D([4481,4694,4597,4918],0); -ELEMENTS[16365] = Fluid3D([4597,4481,4918,4545],0); -ELEMENTS[16366] = Fluid3D([4918,4597,4545,5100],0); -ELEMENTS[16367] = Fluid3D([4694,4483,5091,4969],0); -ELEMENTS[16368] = Fluid3D([4694,4415,4969,4843],0); -ELEMENTS[16369] = Fluid3D([4694,4415,4843,4359],0); -ELEMENTS[16370] = Fluid3D([4483,4249,4160,3874],0); -ELEMENTS[16371] = Fluid3D([4249,4481,4597,4143],0); -ELEMENTS[16372] = Fluid3D([4597,4249,4143,4160],0); -ELEMENTS[16373] = Fluid3D([4481,4597,4143,4545],0); -ELEMENTS[16374] = Fluid3D([4143,4597,4160,4356],0); -ELEMENTS[16375] = Fluid3D([4143,4597,4356,4545],0); -ELEMENTS[16376] = Fluid3D([4356,4143,4545,4039],0); -ELEMENTS[16377] = Fluid3D([4597,4356,4545,5100],0); -ELEMENTS[16378] = Fluid3D([4597,4694,5091,4918],0); -ELEMENTS[16379] = Fluid3D([3982,4481,4143,4543],0); -ELEMENTS[16380] = Fluid3D([5091,4597,4918,5100],0); -ELEMENTS[16381] = Fluid3D([4415,4249,3874,4359],0); -ELEMENTS[16382] = Fluid3D([4969,4694,4843,5279],0); -ELEMENTS[16383] = Fluid3D([4969,4694,5279,5091],0); -ELEMENTS[16384] = Fluid3D([4694,4843,5279,4952],0); -ELEMENTS[16385] = Fluid3D([4249,3982,4143,3874],0); -ELEMENTS[16386] = Fluid3D([4359,3982,4249,3874],0); -ELEMENTS[16387] = Fluid3D([4843,4969,5279,5374],0); -ELEMENTS[16388] = Fluid3D([4969,5279,5374,5585],0); -ELEMENTS[16389] = Fluid3D([4969,5279,5585,5091],0); -ELEMENTS[16390] = Fluid3D([4249,4143,4160,3874],0); -ELEMENTS[16391] = Fluid3D([4415,4483,4969,4203],0); -ELEMENTS[16392] = Fluid3D([4597,4160,4356,4666],0); -ELEMENTS[16393] = Fluid3D([4356,4597,4666,5100],0); -ELEMENTS[16394] = Fluid3D([4597,4160,4666,4483],0); -ELEMENTS[16395] = Fluid3D([4415,4969,4843,4756],0); -ELEMENTS[16396] = Fluid3D([4843,4415,4756,4193],0); -ELEMENTS[16397] = Fluid3D([4415,4756,4193,4203],0); -ELEMENTS[16398] = Fluid3D([4193,4415,4203,3874],0); -ELEMENTS[16399] = Fluid3D([4415,4969,4756,4203],0); -ELEMENTS[16400] = Fluid3D([4969,4843,4756,5374],0); -ELEMENTS[16401] = Fluid3D([4483,4597,5091,4666],0); -ELEMENTS[16402] = Fluid3D([4543,4918,4481,4545],0); -ELEMENTS[16403] = Fluid3D([4160,4356,4666,4169],0); -ELEMENTS[16404] = Fluid3D([4356,4666,4169,4625],0); -ELEMENTS[16405] = Fluid3D([4356,4666,4625,5100],0); -ELEMENTS[16406] = Fluid3D([4666,4169,4625,4672],0); -ELEMENTS[16407] = Fluid3D([4666,4169,4672,4427],0); -ELEMENTS[16408] = Fluid3D([4666,4169,4427,4160],0); -ELEMENTS[16409] = Fluid3D([5279,5374,5585,6002],0); -ELEMENTS[16410] = Fluid3D([5279,5374,6002,5517],0); -ELEMENTS[16411] = Fluid3D([6002,5279,5517,5673],0); -ELEMENTS[16412] = Fluid3D([5279,5517,5673,4952],0); -ELEMENTS[16413] = Fluid3D([5517,6002,5673,6132],0); -ELEMENTS[16414] = Fluid3D([5673,5517,6132,5855],0); -ELEMENTS[16415] = Fluid3D([5517,6002,6132,5494],0); -ELEMENTS[16416] = Fluid3D([5585,5279,6002,5889],0); -ELEMENTS[16417] = Fluid3D([5585,5279,5889,5091],0); -ELEMENTS[16418] = Fluid3D([5374,5585,6002,5872],0); -ELEMENTS[16419] = Fluid3D([5585,6002,5872,6192],0); -ELEMENTS[16420] = Fluid3D([5585,6002,6192,5889],0); -ELEMENTS[16421] = Fluid3D([5374,5585,5872,5395],0); -ELEMENTS[16422] = Fluid3D([5872,5374,5395,5572],0); -ELEMENTS[16423] = Fluid3D([5872,5374,5572,5494],0); -ELEMENTS[16424] = Fluid3D([5374,5585,5395,4969],0); -ELEMENTS[16425] = Fluid3D([5279,6002,5889,5673],0); -ELEMENTS[16426] = Fluid3D([4483,5091,4969,4934],0); -ELEMENTS[16427] = Fluid3D([4969,4483,4934,4634],0); -ELEMENTS[16428] = Fluid3D([4969,4483,4634,4203],0); -ELEMENTS[16429] = Fluid3D([4483,4934,4634,4427],0); -ELEMENTS[16430] = Fluid3D([4483,5091,4934,4666],0); -ELEMENTS[16431] = Fluid3D([4934,4969,4634,5395],0); -ELEMENTS[16432] = Fluid3D([5279,5374,5517,4843],0); -ELEMENTS[16433] = Fluid3D([4169,4625,4672,4303],0); -ELEMENTS[16434] = Fluid3D([4672,4169,4303,4089],0); -ELEMENTS[16435] = Fluid3D([4625,4672,4303,4867],0); -ELEMENTS[16436] = Fluid3D([4672,4303,4867,4544],0); -ELEMENTS[16437] = Fluid3D([4169,4303,4089,3812],0); -ELEMENTS[16438] = Fluid3D([4169,4303,3812,3984],0); -ELEMENTS[16439] = Fluid3D([4169,4303,3984,4625],0); -ELEMENTS[16440] = Fluid3D([4672,4303,4544,4089],0); -ELEMENTS[16441] = Fluid3D([4303,4867,4544,4534],0); -ELEMENTS[16442] = Fluid3D([4544,4303,4534,4071],0); -ELEMENTS[16443] = Fluid3D([4867,4544,4534,5017],0); -ELEMENTS[16444] = Fluid3D([4867,4544,5017,5093],0); -ELEMENTS[16445] = Fluid3D([4867,4544,5093,4672],0); -ELEMENTS[16446] = Fluid3D([4303,4867,4534,4486],0); -ELEMENTS[16447] = Fluid3D([4867,4534,4486,5047],0); -ELEMENTS[16448] = Fluid3D([4867,4534,5047,5017],0); -ELEMENTS[16449] = Fluid3D([4303,4867,4486,4625],0); -ELEMENTS[16450] = Fluid3D([4544,4303,4071,4089],0); -ELEMENTS[16451] = Fluid3D([4534,4544,4071,4473],0); -ELEMENTS[16452] = Fluid3D([4534,4544,4473,5017],0); -ELEMENTS[16453] = Fluid3D([4544,4071,4473,4205],0); -ELEMENTS[16454] = Fluid3D([4071,4473,4205,4023],0); -ELEMENTS[16455] = Fluid3D([4071,4534,4473,4190],0); -ELEMENTS[16456] = Fluid3D([4534,4473,4190,4731],0); -ELEMENTS[16457] = Fluid3D([4534,4473,4731,5017],0); -ELEMENTS[16458] = Fluid3D([4071,4534,4190,4126],0); -ELEMENTS[16459] = Fluid3D([4534,4190,4126,4485],0); -ELEMENTS[16460] = Fluid3D([4534,4190,4485,4731],0); -ELEMENTS[16461] = Fluid3D([4071,4534,4126,4303],0); -ELEMENTS[16462] = Fluid3D([4544,4071,4205,4089],0); -ELEMENTS[16463] = Fluid3D([4473,4071,4190,4023],0); -ELEMENTS[16464] = Fluid3D([4625,4672,4867,5130],0); -ELEMENTS[16465] = Fluid3D([4672,4867,5130,5093],0); -ELEMENTS[16466] = Fluid3D([4625,4672,5130,4666],0); -ELEMENTS[16467] = Fluid3D([4867,4625,5130,5143],0); -ELEMENTS[16468] = Fluid3D([4625,5130,5143,5100],0); -ELEMENTS[16469] = Fluid3D([4867,4625,5143,4486],0); -ELEMENTS[16470] = Fluid3D([5130,4867,5143,5479],0); -ELEMENTS[16471] = Fluid3D([5130,4867,5479,5093],0); -ELEMENTS[16472] = Fluid3D([4867,5143,5479,5047],0); -ELEMENTS[16473] = Fluid3D([5143,5130,5479,5713],0); -ELEMENTS[16474] = Fluid3D([5130,5479,5713,5093],0); -ELEMENTS[16475] = Fluid3D([4473,4544,4205,4750],0); -ELEMENTS[16476] = Fluid3D([4473,4544,4750,5017],0); -ELEMENTS[16477] = Fluid3D([4544,4205,4750,4516],0); -ELEMENTS[16478] = Fluid3D([4544,4205,4516,4089],0); -ELEMENTS[16479] = Fluid3D([4205,4473,4750,4406],0); -ELEMENTS[16480] = Fluid3D([4750,4205,4406,4416],0); -ELEMENTS[16481] = Fluid3D([4750,4205,4416,4516],0); -ELEMENTS[16482] = Fluid3D([4205,4473,4406,4023],0); -ELEMENTS[16483] = Fluid3D([4473,4750,4406,4849],0); -ELEMENTS[16484] = Fluid3D([4406,4750,4416,4884],0); -ELEMENTS[16485] = Fluid3D([4406,4750,4884,4849],0); -ELEMENTS[16486] = Fluid3D([4884,4406,4849,4411],0); -ELEMENTS[16487] = Fluid3D([4406,4849,4411,4469],0); -ELEMENTS[16488] = Fluid3D([4750,4416,4884,4978],0); -ELEMENTS[16489] = Fluid3D([4750,4416,4978,4516],0); -ELEMENTS[16490] = Fluid3D([4884,4750,4978,5261],0); -ELEMENTS[16491] = Fluid3D([4884,4750,5261,4849],0); -ELEMENTS[16492] = Fluid3D([4750,4978,5261,5093],0); -ELEMENTS[16493] = Fluid3D([4416,4406,4884,4365],0); -ELEMENTS[16494] = Fluid3D([4416,4884,4978,4695],0); -ELEMENTS[16495] = Fluid3D([4884,4978,4695,5525],0); -ELEMENTS[16496] = Fluid3D([4978,4695,5525,5169],0); -ELEMENTS[16497] = Fluid3D([4978,4695,5169,4606],0); -ELEMENTS[16498] = Fluid3D([4978,4695,4606,4416],0); -ELEMENTS[16499] = Fluid3D([4416,4884,4695,4365],0); -ELEMENTS[16500] = Fluid3D([4884,4978,5525,5261],0); -ELEMENTS[16501] = Fluid3D([4695,5525,5169,5207],0); -ELEMENTS[16502] = Fluid3D([4695,5525,5207,5033],0); -ELEMENTS[16503] = Fluid3D([5525,5169,5207,5845],0); -ELEMENTS[16504] = Fluid3D([5525,5169,5845,5684],0); -ELEMENTS[16505] = Fluid3D([5525,5169,5684,4978],0); -ELEMENTS[16506] = Fluid3D([5525,5207,5033,5654],0); -ELEMENTS[16507] = Fluid3D([5033,5525,5654,5605],0); -ELEMENTS[16508] = Fluid3D([5033,5525,5605,4884],0); -ELEMENTS[16509] = Fluid3D([5525,5207,5654,5845],0); -ELEMENTS[16510] = Fluid3D([5169,4695,5207,4663],0); -ELEMENTS[16511] = Fluid3D([5169,4695,4663,4606],0); -ELEMENTS[16512] = Fluid3D([4695,5207,4663,4653],0); -ELEMENTS[16513] = Fluid3D([4695,5207,4653,5033],0); -ELEMENTS[16514] = Fluid3D([5207,5169,4663,5354],0); -ELEMENTS[16515] = Fluid3D([5207,5169,5354,5845],0); -ELEMENTS[16516] = Fluid3D([4663,5207,5354,5028],0); -ELEMENTS[16517] = Fluid3D([5207,5354,5028,5671],0); -ELEMENTS[16518] = Fluid3D([5207,5354,5671,5845],0); -ELEMENTS[16519] = Fluid3D([4663,5207,5028,4653],0); -ELEMENTS[16520] = Fluid3D([4695,5525,5033,4884],0); -ELEMENTS[16521] = Fluid3D([5354,4663,5028,5081],0); -ELEMENTS[16522] = Fluid3D([5169,4663,5354,4946],0); -ELEMENTS[16523] = Fluid3D([5169,4663,4946,4606],0); -ELEMENTS[16524] = Fluid3D([5354,5169,4946,5600],0); -ELEMENTS[16525] = Fluid3D([5354,5169,5600,5845],0); -ELEMENTS[16526] = Fluid3D([4663,5354,4946,5081],0); -ELEMENTS[16527] = Fluid3D([4946,5354,5600,5577],0); -ELEMENTS[16528] = Fluid3D([5600,4946,5577,5378],0); -ELEMENTS[16529] = Fluid3D([5600,4946,5378,5249],0); -ELEMENTS[16530] = Fluid3D([5600,4946,5249,5169],0); -ELEMENTS[16531] = Fluid3D([4946,5354,5577,5081],0); -ELEMENTS[16532] = Fluid3D([5354,5600,5577,5967],0); -ELEMENTS[16533] = Fluid3D([5354,5600,5967,5845],0); -ELEMENTS[16534] = Fluid3D([5600,5577,5967,6006],0); -ELEMENTS[16535] = Fluid3D([5577,5354,5967,5708],0); -ELEMENTS[16536] = Fluid3D([5967,5577,5708,5785],0); -ELEMENTS[16537] = Fluid3D([5577,5708,5785,5136],0); -ELEMENTS[16538] = Fluid3D([5577,5708,5136,5081],0); -ELEMENTS[16539] = Fluid3D([5785,5577,5136,5214],0); -ELEMENTS[16540] = Fluid3D([5577,5967,6006,5785],0); -ELEMENTS[16541] = Fluid3D([5577,5600,5378,6006],0); -ELEMENTS[16542] = Fluid3D([5967,5600,6006,6172],0); -ELEMENTS[16543] = Fluid3D([5967,5600,6172,5845],0); -ELEMENTS[16544] = Fluid3D([5600,6006,6172,5950],0); -ELEMENTS[16545] = Fluid3D([5600,6006,5950,5378],0); -ELEMENTS[16546] = Fluid3D([6172,5600,5950,5684],0); -ELEMENTS[16547] = Fluid3D([6006,5967,6172,6626],0); -ELEMENTS[16548] = Fluid3D([5967,6172,6626,6602],0); -ELEMENTS[16549] = Fluid3D([6006,5967,6626,6395],0); -ELEMENTS[16550] = Fluid3D([6172,6006,6626,6709],0); -ELEMENTS[16551] = Fluid3D([6172,6006,6709,5950],0); -ELEMENTS[16552] = Fluid3D([6006,6626,6709,6494],0); -ELEMENTS[16553] = Fluid3D([5967,6172,6602,5845],0); -ELEMENTS[16554] = Fluid3D([6172,6626,6602,7098],0); -ELEMENTS[16555] = Fluid3D([6172,6626,7098,6709],0); -ELEMENTS[16556] = Fluid3D([6626,6602,7098,7306],0); -ELEMENTS[16557] = Fluid3D([6626,6602,7306,6315],0); -ELEMENTS[16558] = Fluid3D([7098,6626,7306,7425],0); -ELEMENTS[16559] = Fluid3D([6626,7306,7425,7149],0); -ELEMENTS[16560] = Fluid3D([7098,6626,7425,6709],0); -ELEMENTS[16561] = Fluid3D([6602,6172,7098,6692],0); -ELEMENTS[16562] = Fluid3D([6602,6172,6692,5845],0); -ELEMENTS[16563] = Fluid3D([6172,7098,6692,6770],0); -ELEMENTS[16564] = Fluid3D([7098,6602,6692,7351],0); -ELEMENTS[16565] = Fluid3D([6172,7098,6770,6709],0); -ELEMENTS[16566] = Fluid3D([7098,6602,7351,7306],0); -ELEMENTS[16567] = Fluid3D([7098,6692,6770,7488],0); -ELEMENTS[16568] = Fluid3D([7098,6692,7488,7351],0); -ELEMENTS[16569] = Fluid3D([6692,6770,7488,6863],0); -ELEMENTS[16570] = Fluid3D([6770,7098,7488,7568],0); -ELEMENTS[16571] = Fluid3D([6770,7488,6863,7390],0); -ELEMENTS[16572] = Fluid3D([6770,7488,7390,7568],0); -ELEMENTS[16573] = Fluid3D([6770,7098,7568,6709],0); -ELEMENTS[16574] = Fluid3D([6692,6770,6863,6230],0); -ELEMENTS[16575] = Fluid3D([6692,6770,6230,6172],0); -ELEMENTS[16576] = Fluid3D([6770,6863,6230,6366],0); -ELEMENTS[16577] = Fluid3D([6863,6692,6230,6412],0); -ELEMENTS[16578] = Fluid3D([6863,6692,6412,7143],0); -ELEMENTS[16579] = Fluid3D([6863,6692,7143,7488],0); -ELEMENTS[16580] = Fluid3D([6770,6863,6366,7390],0); -ELEMENTS[16581] = Fluid3D([6863,6230,6366,6196],0); -ELEMENTS[16582] = Fluid3D([6863,6230,6196,6412],0); -ELEMENTS[16583] = Fluid3D([6230,6366,6196,5765],0); -ELEMENTS[16584] = Fluid3D([6366,6863,6196,6982],0); -ELEMENTS[16585] = Fluid3D([6366,6863,6982,7390],0); -ELEMENTS[16586] = Fluid3D([6366,6196,5765,6140],0); -ELEMENTS[16587] = Fluid3D([6196,5765,6140,5626],0); -ELEMENTS[16588] = Fluid3D([6366,6196,6140,6982],0); -ELEMENTS[16589] = Fluid3D([6196,5765,5626,5684],0); -ELEMENTS[16590] = Fluid3D([7306,7098,7425,7966],0); -ELEMENTS[16591] = Fluid3D([7306,7098,7966,7351],0); -ELEMENTS[16592] = Fluid3D([7425,7306,7966,8046],0); -ELEMENTS[16593] = Fluid3D([7098,7425,7966,7568],0); -ELEMENTS[16594] = Fluid3D([6196,6230,5765,5684],0); -ELEMENTS[16595] = Fluid3D([6230,5765,5684,5950],0); -ELEMENTS[16596] = Fluid3D([6230,6366,5765,5950],0); -ELEMENTS[16597] = Fluid3D([4946,5577,5378,5136],0); -ELEMENTS[16598] = Fluid3D([4672,4169,4089,4427],0); -ELEMENTS[16599] = Fluid3D([4160,4143,4356,3844],0); -ELEMENTS[16600] = Fluid3D([4143,4356,3844,4039],0); -ELEMENTS[16601] = Fluid3D([4160,4143,3844,3528],0); -ELEMENTS[16602] = Fluid3D([4356,4160,3844,4169],0); -ELEMENTS[16603] = Fluid3D([4750,4544,4516,5093],0); -ELEMENTS[16604] = Fluid3D([6277,6243,5940,6750],0); -ELEMENTS[16605] = Fluid3D([6243,5940,6750,6458],0); -ELEMENTS[16606] = Fluid3D([6277,6243,6750,6900],0); -ELEMENTS[16607] = Fluid3D([5940,6277,6750,6496],0); -ELEMENTS[16608] = Fluid3D([6750,5940,6496,6458],0); -ELEMENTS[16609] = Fluid3D([6496,6750,6458,7218],0); -ELEMENTS[16610] = Fluid3D([5586,6068,5589,5077],0); -ELEMENTS[16611] = Fluid3D([5328,5413,5871,5392],0); -ELEMENTS[16612] = Fluid3D([6647,6741,6068,6878],0); -ELEMENTS[16613] = Fluid3D([5395,5872,5572,5919],0); -ELEMENTS[16614] = Fluid3D([5395,5872,5919,5951],0); -ELEMENTS[16615] = Fluid3D([5872,5919,5951,6524],0); -ELEMENTS[16616] = Fluid3D([5872,5919,6524,6303],0); -ELEMENTS[16617] = Fluid3D([5872,5919,6303,5572],0); -ELEMENTS[16618] = Fluid3D([5572,5395,5919,5306],0); -ELEMENTS[16619] = Fluid3D([5395,5919,5306,5514],0); -ELEMENTS[16620] = Fluid3D([5919,5951,6524,6282],0); -ELEMENTS[16621] = Fluid3D([5919,5306,5514,5676],0); -ELEMENTS[16622] = Fluid3D([5919,5306,5676,5812],0); -ELEMENTS[16623] = Fluid3D([5919,5306,5812,5572],0); -ELEMENTS[16624] = Fluid3D([5919,5951,6282,5514],0); -ELEMENTS[16625] = Fluid3D([5395,5919,5514,5951],0); -ELEMENTS[16626] = Fluid3D([5572,5395,5306,4756],0); -ELEMENTS[16627] = Fluid3D([5306,5514,5676,5170],0); -ELEMENTS[16628] = Fluid3D([5514,5676,5170,5645],0); -ELEMENTS[16629] = Fluid3D([5306,5514,5170,4911],0); -ELEMENTS[16630] = Fluid3D([5170,5514,5645,5131],0); -ELEMENTS[16631] = Fluid3D([5306,5514,4911,5395],0); -ELEMENTS[16632] = Fluid3D([5170,5514,5131,4911],0); -ELEMENTS[16633] = Fluid3D([5676,5306,5170,5231],0); -ELEMENTS[16634] = Fluid3D([5514,5676,5645,6282],0); -ELEMENTS[16635] = Fluid3D([5170,5306,4911,4717],0); -ELEMENTS[16636] = Fluid3D([5170,5306,4717,5231],0); -ELEMENTS[16637] = Fluid3D([5306,4717,5231,4926],0); -ELEMENTS[16638] = Fluid3D([5231,5306,4926,5572],0); -ELEMENTS[16639] = Fluid3D([5306,4717,4926,4911],0); -ELEMENTS[16640] = Fluid3D([4717,5231,4926,4738],0); -ELEMENTS[16641] = Fluid3D([5231,4926,4738,5053],0); -ELEMENTS[16642] = Fluid3D([4926,4738,5053,4467],0); -ELEMENTS[16643] = Fluid3D([5053,4926,4467,4840],0); -ELEMENTS[16644] = Fluid3D([5231,4926,5053,5572],0); -ELEMENTS[16645] = Fluid3D([4738,5053,4467,4737],0); -ELEMENTS[16646] = Fluid3D([4926,4738,4467,4433],0); -ELEMENTS[16647] = Fluid3D([4467,4926,4433,4756],0); -ELEMENTS[16648] = Fluid3D([4926,4738,4433,4717],0); -ELEMENTS[16649] = Fluid3D([4433,4926,4717,4911],0); -ELEMENTS[16650] = Fluid3D([4911,5170,4717,4590],0); -ELEMENTS[16651] = Fluid3D([5170,4717,4590,4739],0); -ELEMENTS[16652] = Fluid3D([4911,5170,4590,5131],0); -ELEMENTS[16653] = Fluid3D([4717,4590,4739,4258],0); -ELEMENTS[16654] = Fluid3D([4717,4590,4258,4327],0); -ELEMENTS[16655] = Fluid3D([4717,4590,4327,4911],0); -ELEMENTS[16656] = Fluid3D([4590,4739,4258,4321],0); -ELEMENTS[16657] = Fluid3D([4739,4258,4321,4230],0); -ELEMENTS[16658] = Fluid3D([4258,4321,4230,3894],0); -ELEMENTS[16659] = Fluid3D([4739,4258,4230,4799],0); -ELEMENTS[16660] = Fluid3D([4230,4739,4799,4698],0); -ELEMENTS[16661] = Fluid3D([4739,4799,4698,5322],0); -ELEMENTS[16662] = Fluid3D([4230,4739,4698,4321],0); -ELEMENTS[16663] = Fluid3D([4739,4698,4321,4837],0); -ELEMENTS[16664] = Fluid3D([4739,4698,4837,5322],0); -ELEMENTS[16665] = Fluid3D([4698,4321,4837,4617],0); -ELEMENTS[16666] = Fluid3D([4739,4799,5322,5156],0); -ELEMENTS[16667] = Fluid3D([4739,4799,5156,4717],0); -ELEMENTS[16668] = Fluid3D([5156,4739,4717,5170],0); -ELEMENTS[16669] = Fluid3D([4717,5156,5170,5231],0); -ELEMENTS[16670] = Fluid3D([4717,5156,5231,4799],0); -ELEMENTS[16671] = Fluid3D([5156,4739,5170,5322],0); -ELEMENTS[16672] = Fluid3D([4698,4230,4321,3894],0); -ELEMENTS[16673] = Fluid3D([5156,5170,5231,5676],0); -ELEMENTS[16674] = Fluid3D([5156,5170,5676,5322],0); -ELEMENTS[16675] = Fluid3D([4739,4799,4717,4258],0); -ELEMENTS[16676] = Fluid3D([5156,5231,4799,5426],0); -ELEMENTS[16677] = Fluid3D([5156,5231,5426,5676],0); -ELEMENTS[16678] = Fluid3D([4321,4739,4837,4590],0); -ELEMENTS[16679] = Fluid3D([4739,4837,4590,5170],0); -ELEMENTS[16680] = Fluid3D([4837,4590,5170,5131],0); -ELEMENTS[16681] = Fluid3D([4837,4321,4590,4413],0); -ELEMENTS[16682] = Fluid3D([4590,4837,4413,5131],0); -ELEMENTS[16683] = Fluid3D([4739,4837,5170,5322],0); -ELEMENTS[16684] = Fluid3D([4799,5156,5426,5322],0); -ELEMENTS[16685] = Fluid3D([4837,4321,4413,4617],0); -ELEMENTS[16686] = Fluid3D([4321,4590,4413,4044],0); -ELEMENTS[16687] = Fluid3D([4590,4413,4044,4476],0); -ELEMENTS[16688] = Fluid3D([4590,4413,4476,5131],0); -ELEMENTS[16689] = Fluid3D([4044,4590,4476,4327],0); -ELEMENTS[16690] = Fluid3D([4413,4044,4476,3996],0); -ELEMENTS[16691] = Fluid3D([4476,4413,3996,4431],0); -ELEMENTS[16692] = Fluid3D([4476,4413,4431,5131],0); -ELEMENTS[16693] = Fluid3D([4413,4044,3996,3939],0); -ELEMENTS[16694] = Fluid3D([3996,4413,3939,4048],0); -ELEMENTS[16695] = Fluid3D([3996,4413,4048,4431],0); -ELEMENTS[16696] = Fluid3D([3996,4476,4431,4145],0); -ELEMENTS[16697] = Fluid3D([4413,4044,3939,4321],0); -ELEMENTS[16698] = Fluid3D([4413,3939,4048,4285],0); -ELEMENTS[16699] = Fluid3D([4321,4590,4044,4258],0); -ELEMENTS[16700] = Fluid3D([4044,4476,3996,3952],0); -ELEMENTS[16701] = Fluid3D([4476,3996,3952,4145],0); -ELEMENTS[16702] = Fluid3D([4044,4476,3952,4327],0); -ELEMENTS[16703] = Fluid3D([4044,3996,3939,3618],0); -ELEMENTS[16704] = Fluid3D([3939,4044,3618,3894],0); -ELEMENTS[16705] = Fluid3D([3996,3939,3618,3655],0); -ELEMENTS[16706] = Fluid3D([3939,3618,3655,3401],0); -ELEMENTS[16707] = Fluid3D([3939,3618,3401,3894],0); -ELEMENTS[16708] = Fluid3D([4044,3996,3618,3952],0); -ELEMENTS[16709] = Fluid3D([3996,3939,3655,4048],0); -ELEMENTS[16710] = Fluid3D([3618,3996,3655,3575],0); -ELEMENTS[16711] = Fluid3D([3996,3655,3575,3876],0); -ELEMENTS[16712] = Fluid3D([3655,3575,3876,3367],0); -ELEMENTS[16713] = Fluid3D([3618,3996,3575,3952],0); -ELEMENTS[16714] = Fluid3D([3655,3618,3575,3367],0); -ELEMENTS[16715] = Fluid3D([3996,3655,3876,4048],0); -ELEMENTS[16716] = Fluid3D([5395,5872,5951,5585],0); -ELEMENTS[16717] = Fluid3D([5919,6524,6303,6565],0); -ELEMENTS[16718] = Fluid3D([6303,5919,6565,5812],0); -ELEMENTS[16719] = Fluid3D([5919,6524,6565,6282],0); -ELEMENTS[16720] = Fluid3D([6524,6303,6565,7110],0); -ELEMENTS[16721] = Fluid3D([6303,6565,7110,6813],0); -ELEMENTS[16722] = Fluid3D([6565,6524,7110,7192],0); -ELEMENTS[16723] = Fluid3D([7110,6303,6813,6919],0); -ELEMENTS[16724] = Fluid3D([6524,6303,7110,6779],0); -ELEMENTS[16725] = Fluid3D([7110,6303,6919,6779],0); -ELEMENTS[16726] = Fluid3D([6524,6303,6779,5872],0); -ELEMENTS[16727] = Fluid3D([6303,6565,6813,5812],0); -ELEMENTS[16728] = Fluid3D([6565,6524,7192,6282],0); -ELEMENTS[16729] = Fluid3D([7110,6565,7192,7408],0); -ELEMENTS[16730] = Fluid3D([7110,6565,7408,6813],0); -ELEMENTS[16731] = Fluid3D([6565,7192,7408,6999],0); -ELEMENTS[16732] = Fluid3D([6565,7192,6999,6282],0); -ELEMENTS[16733] = Fluid3D([7408,6565,6999,6803],0); -ELEMENTS[16734] = Fluid3D([7408,6565,6803,6813],0); -ELEMENTS[16735] = Fluid3D([6565,6999,6803,6206],0); -ELEMENTS[16736] = Fluid3D([6565,6999,6206,6282],0); -ELEMENTS[16737] = Fluid3D([6999,6803,6206,6627],0); -ELEMENTS[16738] = Fluid3D([7192,7110,7408,7924],0); -ELEMENTS[16739] = Fluid3D([7110,7408,7924,7767],0); -ELEMENTS[16740] = Fluid3D([7192,7110,7924,7608],0); -ELEMENTS[16741] = Fluid3D([7192,7110,7608,6524],0); -ELEMENTS[16742] = Fluid3D([7408,7192,7924,7903],0); -ELEMENTS[16743] = Fluid3D([7924,7408,7903,8305],0); -ELEMENTS[16744] = Fluid3D([7924,7408,8305,7767],0); -ELEMENTS[16745] = Fluid3D([7408,7192,7903,6999],0); -ELEMENTS[16746] = Fluid3D([7110,7408,7767,6813],0); -ELEMENTS[16747] = Fluid3D([6803,6565,6206,5812],0); -ELEMENTS[16748] = Fluid3D([5951,6524,6282,6634],0); -ELEMENTS[16749] = Fluid3D([5951,6524,6634,6192],0); -ELEMENTS[16750] = Fluid3D([6524,6282,6634,7192],0); -ELEMENTS[16751] = Fluid3D([6282,5951,6634,5986],0); -ELEMENTS[16752] = Fluid3D([5951,6634,5986,6667],0); -ELEMENTS[16753] = Fluid3D([6634,6282,5986,6696],0); -ELEMENTS[16754] = Fluid3D([6634,6282,6696,7192],0); -ELEMENTS[16755] = Fluid3D([5986,6634,6696,6641],0); -ELEMENTS[16756] = Fluid3D([6282,5951,5986,5514],0); -ELEMENTS[16757] = Fluid3D([6634,6696,6641,7376],0); -ELEMENTS[16758] = Fluid3D([6634,6696,7376,7192],0); -ELEMENTS[16759] = Fluid3D([6696,6641,7376,7265],0); -ELEMENTS[16760] = Fluid3D([6696,6641,7265,6770],0); -ELEMENTS[16761] = Fluid3D([6641,7376,7265,7419],0); -ELEMENTS[16762] = Fluid3D([7376,7265,7419,8049],0); -ELEMENTS[16763] = Fluid3D([6641,7376,7419,6667],0); -ELEMENTS[16764] = Fluid3D([7376,7265,8049,7690],0); -ELEMENTS[16765] = Fluid3D([7376,7265,7690,6696],0); -ELEMENTS[16766] = Fluid3D([7265,8049,7690,7568],0); -ELEMENTS[16767] = Fluid3D([7690,7265,7568,6709],0); -ELEMENTS[16768] = Fluid3D([5986,6634,6641,6667],0); -ELEMENTS[16769] = Fluid3D([6634,6641,6667,7376],0); -ELEMENTS[16770] = Fluid3D([6282,5986,6696,6100],0); -ELEMENTS[16771] = Fluid3D([5986,6696,6100,5950],0); -ELEMENTS[16772] = Fluid3D([6282,5986,6100,5514],0); -ELEMENTS[16773] = Fluid3D([6696,6282,6100,6744],0); -ELEMENTS[16774] = Fluid3D([6696,6282,6744,7192],0); -ELEMENTS[16775] = Fluid3D([6282,6100,6744,6206],0); -ELEMENTS[16776] = Fluid3D([6100,6696,6744,6709],0); -ELEMENTS[16777] = Fluid3D([6999,7408,6803,7567],0); -ELEMENTS[16778] = Fluid3D([7408,6803,7567,7693],0); -ELEMENTS[16779] = Fluid3D([6999,7408,7567,7903],0); -ELEMENTS[16780] = Fluid3D([6803,6999,7567,6627],0); -ELEMENTS[16781] = Fluid3D([6696,5986,6641,5950],0); -ELEMENTS[16782] = Fluid3D([7192,7924,7903,7962],0); -ELEMENTS[16783] = Fluid3D([7924,7903,7962,8678],0); -ELEMENTS[16784] = Fluid3D([7192,7924,7962,7608],0); -ELEMENTS[16785] = Fluid3D([7903,7962,8678,8440],0); -ELEMENTS[16786] = Fluid3D([8678,7903,8440,8735],0); -ELEMENTS[16787] = Fluid3D([7903,7962,8440,7690],0); -ELEMENTS[16788] = Fluid3D([7903,7192,7962,7690],0); -ELEMENTS[16789] = Fluid3D([8678,7903,8735,8305],0); -ELEMENTS[16790] = Fluid3D([7962,8678,8440,8788],0); -ELEMENTS[16791] = Fluid3D([8678,8440,8788,9361],0); -ELEMENTS[16792] = Fluid3D([8440,8788,9361,8852],0); -ELEMENTS[16793] = Fluid3D([7962,8678,8788,8547],0); -ELEMENTS[16794] = Fluid3D([8678,8788,8547,9475],0); -ELEMENTS[16795] = Fluid3D([8678,8788,9475,9361],0); -ELEMENTS[16796] = Fluid3D([7962,8678,8547,7924],0); -ELEMENTS[16797] = Fluid3D([8678,8440,9361,8735],0); -ELEMENTS[16798] = Fluid3D([8440,7962,8788,8049],0); -ELEMENTS[16799] = Fluid3D([8788,7962,8547,8165],0); -ELEMENTS[16800] = Fluid3D([8788,7962,8165,8049],0); -ELEMENTS[16801] = Fluid3D([7962,8547,8165,7608],0); -ELEMENTS[16802] = Fluid3D([8547,8788,8165,9130],0); -ELEMENTS[16803] = Fluid3D([7924,7903,8678,8305],0); -ELEMENTS[16804] = Fluid3D([7903,8440,8735,8043],0); -ELEMENTS[16805] = Fluid3D([7903,8440,8043,7690],0); -ELEMENTS[16806] = Fluid3D([8735,7903,8043,7567],0); -ELEMENTS[16807] = Fluid3D([8440,8735,8043,9201],0); -ELEMENTS[16808] = Fluid3D([5676,5170,5645,5322],0); -ELEMENTS[16809] = Fluid3D([3575,3996,3876,4145],0); -ELEMENTS[16810] = Fluid3D([5951,5872,6524,6192],0); -ELEMENTS[16811] = Fluid3D([7924,7110,7767,7806],0); -ELEMENTS[16812] = Fluid3D([7924,7110,7806,7608],0); -ELEMENTS[16813] = Fluid3D([7110,7767,7806,6919],0); -ELEMENTS[16814] = Fluid3D([7767,7924,7806,8428],0); -ELEMENTS[16815] = Fluid3D([7924,7806,8428,8547],0); -ELEMENTS[16816] = Fluid3D([7806,7767,8428,8205],0); -ELEMENTS[16817] = Fluid3D([7806,7767,8205,6919],0); -ELEMENTS[16818] = Fluid3D([8428,7806,8205,8176],0); -ELEMENTS[16819] = Fluid3D([7767,7924,8428,8305],0); -ELEMENTS[16820] = Fluid3D([7767,8428,8205,8543],0); -ELEMENTS[16821] = Fluid3D([7767,8428,8543,8305],0); -ELEMENTS[16822] = Fluid3D([8428,8205,8543,9429],0); -ELEMENTS[16823] = Fluid3D([8205,7767,8543,7769],0); -ELEMENTS[16824] = Fluid3D([8205,7767,7769,6919],0); -ELEMENTS[16825] = Fluid3D([7767,8543,7769,7869],0); -ELEMENTS[16826] = Fluid3D([7767,8543,7869,8305],0); -ELEMENTS[16827] = Fluid3D([7769,7767,7869,6813],0); -ELEMENTS[16828] = Fluid3D([8543,8205,7769,8582],0); -ELEMENTS[16829] = Fluid3D([8205,7769,8582,7808],0); -ELEMENTS[16830] = Fluid3D([8543,8205,8582,9429],0); -ELEMENTS[16831] = Fluid3D([8582,8205,7808,8704],0); -ELEMENTS[16832] = Fluid3D([8582,8205,8704,9271],0); -ELEMENTS[16833] = Fluid3D([8205,7808,8704,7848],0); -ELEMENTS[16834] = Fluid3D([8205,8704,9271,8546],0); -ELEMENTS[16835] = Fluid3D([8205,8704,8546,7848],0); -ELEMENTS[16836] = Fluid3D([7769,8543,8582,8425],0); -ELEMENTS[16837] = Fluid3D([8543,8582,8425,9279],0); -ELEMENTS[16838] = Fluid3D([8543,8582,9279,9429],0); -ELEMENTS[16839] = Fluid3D([7769,8543,8425,7869],0); -ELEMENTS[16840] = Fluid3D([8582,8205,9271,9429],0); -ELEMENTS[16841] = Fluid3D([8205,7808,7848,6919],0); -ELEMENTS[16842] = Fluid3D([8582,7769,8425,7978],0); -ELEMENTS[16843] = Fluid3D([8582,7769,7978,7808],0); -ELEMENTS[16844] = Fluid3D([7769,8425,7978,7553],0); -ELEMENTS[16845] = Fluid3D([7769,8425,7553,7869],0); -ELEMENTS[16846] = Fluid3D([8425,8582,7978,8883],0); -ELEMENTS[16847] = Fluid3D([8425,8582,8883,9279],0); -ELEMENTS[16848] = Fluid3D([8582,7978,8883,8578],0); -ELEMENTS[16849] = Fluid3D([7978,8425,8883,8093],0); -ELEMENTS[16850] = Fluid3D([7978,8883,8578,8364],0); -ELEMENTS[16851] = Fluid3D([7978,8883,8364,8340],0); -ELEMENTS[16852] = Fluid3D([8883,8578,8364,9235],0); -ELEMENTS[16853] = Fluid3D([8578,8364,9235,8537],0); -ELEMENTS[16854] = Fluid3D([8578,8364,8537,7804],0); -ELEMENTS[16855] = Fluid3D([8578,8364,7804,7978],0); -ELEMENTS[16856] = Fluid3D([8883,8578,9235,9437],0); -ELEMENTS[16857] = Fluid3D([8883,8578,9437,8582],0); -ELEMENTS[16858] = Fluid3D([8578,9235,9437,9456],0); -ELEMENTS[16859] = Fluid3D([9437,8578,9456,8704],0); -ELEMENTS[16860] = Fluid3D([8578,9235,9456,8537],0); -ELEMENTS[16861] = Fluid3D([8582,7978,8578,7808],0); -ELEMENTS[16862] = Fluid3D([8425,7978,7553,8093],0); -ELEMENTS[16863] = Fluid3D([7553,8425,8093,7863],0); -ELEMENTS[16864] = Fluid3D([8093,7553,7863,7151],0); -ELEMENTS[16865] = Fluid3D([8093,7553,7151,7387],0); -ELEMENTS[16866] = Fluid3D([7553,7151,7387,6841],0); -ELEMENTS[16867] = Fluid3D([7553,7151,6841,6980],0); -ELEMENTS[16868] = Fluid3D([7553,7151,6980,7863],0); -ELEMENTS[16869] = Fluid3D([6841,7553,6980,7769],0); -ELEMENTS[16870] = Fluid3D([7151,6841,6980,6272],0); -ELEMENTS[16871] = Fluid3D([8093,7553,7387,7978],0); -ELEMENTS[16872] = Fluid3D([9235,8883,9437,9859],0); -ELEMENTS[16873] = Fluid3D([8883,9437,9859,9279],0); -ELEMENTS[16874] = Fluid3D([9235,8883,9859,9341],0); -ELEMENTS[16875] = Fluid3D([9437,9235,9859,10152],0); -ELEMENTS[16876] = Fluid3D([9235,9859,10152,10059],0); -ELEMENTS[16877] = Fluid3D([9437,9235,10152,9456],0); -ELEMENTS[16878] = Fluid3D([9859,10152,10059,10854],0); -ELEMENTS[16879] = Fluid3D([10059,9859,10854,10123],0); -ELEMENTS[16880] = Fluid3D([9859,10152,10854,10516],0); -ELEMENTS[16881] = Fluid3D([9859,10152,10516,9437],0); -ELEMENTS[16882] = Fluid3D([10152,10854,10516,11276],0); -ELEMENTS[16883] = Fluid3D([10854,10516,11276,11514],0); -ELEMENTS[16884] = Fluid3D([10854,10516,11514,10761],0); -ELEMENTS[16885] = Fluid3D([10854,10516,10761,9859],0); -ELEMENTS[16886] = Fluid3D([10152,10854,11276,10970],0); -ELEMENTS[16887] = Fluid3D([10854,11276,10970,11616],0); -ELEMENTS[16888] = Fluid3D([10152,10854,10970,10059],0); -ELEMENTS[16889] = Fluid3D([10854,11276,11616,11514],0); -ELEMENTS[16890] = Fluid3D([10516,10152,11276,10393],0); -ELEMENTS[16891] = Fluid3D([10516,10152,10393,9437],0); -ELEMENTS[16892] = Fluid3D([10152,11276,10393,10629],0); -ELEMENTS[16893] = Fluid3D([10152,11276,10629,10970],0); -ELEMENTS[16894] = Fluid3D([11276,10393,10629,11297],0); -ELEMENTS[16895] = Fluid3D([10629,11276,11297,11950],0); -ELEMENTS[16896] = Fluid3D([11276,10393,11297,11332],0); -ELEMENTS[16897] = Fluid3D([10393,11297,11332,10834],0); -ELEMENTS[16898] = Fluid3D([11276,10393,11332,10516],0); -ELEMENTS[16899] = Fluid3D([10393,11297,10834,10256],0); -ELEMENTS[16900] = Fluid3D([10393,11297,10256,10629],0); -ELEMENTS[16901] = Fluid3D([10834,10393,10256,9484],0); -ELEMENTS[16902] = Fluid3D([10393,10256,9484,9456],0); -ELEMENTS[16903] = Fluid3D([10834,10393,9484,10248],0); -ELEMENTS[16904] = Fluid3D([10393,9484,10248,9437],0); -ELEMENTS[16905] = Fluid3D([10834,10393,10248,11332],0); -ELEMENTS[16906] = Fluid3D([10393,10152,10629,9456],0); -ELEMENTS[16907] = Fluid3D([9235,9859,10059,9341],0); -ELEMENTS[16908] = Fluid3D([10152,9235,10059,9903],0); -ELEMENTS[16909] = Fluid3D([10152,9235,9903,9456],0); -ELEMENTS[16910] = Fluid3D([9235,10059,9903,9242],0); -ELEMENTS[16911] = Fluid3D([9235,10059,9242,9341],0); -ELEMENTS[16912] = Fluid3D([9903,9235,9242,8537],0); -ELEMENTS[16913] = Fluid3D([10059,9903,9242,10041],0); -ELEMENTS[16914] = Fluid3D([10059,9903,10041,10970],0); -ELEMENTS[16915] = Fluid3D([9242,10059,10041,9635],0); -ELEMENTS[16916] = Fluid3D([10041,9242,9635,9365],0); -ELEMENTS[16917] = Fluid3D([9242,9635,9365,8597],0); -ELEMENTS[16918] = Fluid3D([9242,9635,8597,9341],0); -ELEMENTS[16919] = Fluid3D([9635,10041,9365,9952],0); -ELEMENTS[16920] = Fluid3D([9365,9635,9952,8605],0); -ELEMENTS[16921] = Fluid3D([10041,9365,9952,10058],0); -ELEMENTS[16922] = Fluid3D([9365,9952,10058,9220],0); -ELEMENTS[16923] = Fluid3D([9242,10059,9635,9341],0); -ELEMENTS[16924] = Fluid3D([10041,9242,9365,9903],0); -ELEMENTS[16925] = Fluid3D([10041,9365,10058,9903],0); -ELEMENTS[16926] = Fluid3D([10059,10041,9635,10739],0); -ELEMENTS[16927] = Fluid3D([10041,9635,10739,9952],0); -ELEMENTS[16928] = Fluid3D([10059,10152,9903,10970],0); -ELEMENTS[16929] = Fluid3D([8704,8582,9271,9437],0); -ELEMENTS[16930] = Fluid3D([7978,7769,7553,6841],0); -ELEMENTS[16931] = Fluid3D([11297,10834,10256,11304],0); -ELEMENTS[16932] = Fluid3D([10834,10256,11304,10402],0); -ELEMENTS[16933] = Fluid3D([10256,11297,11304,11187],0); -ELEMENTS[16934] = Fluid3D([11297,11304,11187,12061],0); -ELEMENTS[16935] = Fluid3D([11304,11187,12061,11571],0); -ELEMENTS[16936] = Fluid3D([12061,11304,11571,11542],0); -ELEMENTS[16937] = Fluid3D([11297,11304,12061,11713],0); -ELEMENTS[16938] = Fluid3D([11304,12061,11713,11542],0); -ELEMENTS[16939] = Fluid3D([11304,11187,11571,10564],0); -ELEMENTS[16940] = Fluid3D([11571,11304,10564,11542],0); -ELEMENTS[16941] = Fluid3D([10256,11304,10402,10564],0); -ELEMENTS[16942] = Fluid3D([10256,11304,10564,11187],0); -ELEMENTS[16943] = Fluid3D([10402,10256,10564,9631],0); -ELEMENTS[16944] = Fluid3D([10256,10564,9631,9910],0); -ELEMENTS[16945] = Fluid3D([10256,10564,9910,11187],0); -ELEMENTS[16946] = Fluid3D([9631,10256,9910,9511],0); -ELEMENTS[16947] = Fluid3D([10564,9631,9910,9774],0); -ELEMENTS[16948] = Fluid3D([10256,9910,9511,9456],0); -ELEMENTS[16949] = Fluid3D([9910,10564,9774,10606],0); -ELEMENTS[16950] = Fluid3D([9910,10564,10606,11187],0); -ELEMENTS[16951] = Fluid3D([9631,10256,9511,9484],0); -ELEMENTS[16952] = Fluid3D([10564,9631,9774,10004],0); -ELEMENTS[16953] = Fluid3D([10564,9631,10004,10402],0); -ELEMENTS[16954] = Fluid3D([10564,9774,10606,10666],0); -ELEMENTS[16955] = Fluid3D([11304,10402,10564,11542],0); -ELEMENTS[16956] = Fluid3D([9631,9774,10004,9298],0); -ELEMENTS[16957] = Fluid3D([9631,9774,9298,8981],0); -ELEMENTS[16958] = Fluid3D([9631,9774,8981,9910],0); -ELEMENTS[16959] = Fluid3D([9774,10606,10666,9902],0); -ELEMENTS[16960] = Fluid3D([10564,9774,10666,10004],0); -ELEMENTS[16961] = Fluid3D([10004,9631,9298,9317],0); -ELEMENTS[16962] = Fluid3D([10004,9631,9317,10402],0); -ELEMENTS[16963] = Fluid3D([9631,9298,9317,8671],0); -ELEMENTS[16964] = Fluid3D([10606,10564,10666,11571],0); -ELEMENTS[16965] = Fluid3D([10402,10256,9631,9484],0); -ELEMENTS[16966] = Fluid3D([9774,9910,10606,9678],0); -ELEMENTS[16967] = Fluid3D([9910,10606,9678,10434],0); -ELEMENTS[16968] = Fluid3D([9910,10606,10434,11187],0); -ELEMENTS[16969] = Fluid3D([9774,9910,9678,8981],0); -ELEMENTS[16970] = Fluid3D([9678,9910,10434,9471],0); -ELEMENTS[16971] = Fluid3D([9678,9910,9471,8981],0); -ELEMENTS[16972] = Fluid3D([9910,10434,9471,10218],0); -ELEMENTS[16973] = Fluid3D([9910,10434,10218,11187],0); -ELEMENTS[16974] = Fluid3D([9910,9631,9511,9045],0); -ELEMENTS[16975] = Fluid3D([9511,9910,9045,9456],0); -ELEMENTS[16976] = Fluid3D([9045,9511,9456,8791],0); -ELEMENTS[16977] = Fluid3D([9045,9511,8791,9631],0); -ELEMENTS[16978] = Fluid3D([9511,9456,8791,9484],0); -ELEMENTS[16979] = Fluid3D([9456,9045,8791,8338],0); -ELEMENTS[16980] = Fluid3D([9045,8791,8338,8178],0); -ELEMENTS[16981] = Fluid3D([9045,8791,8178,8671],0); -ELEMENTS[16982] = Fluid3D([8791,8178,8671,7848],0); -ELEMENTS[16983] = Fluid3D([8178,9045,8671,8981],0); -ELEMENTS[16984] = Fluid3D([8178,9045,8981,8311],0); -ELEMENTS[16985] = Fluid3D([9045,8981,8311,9471],0); -ELEMENTS[16986] = Fluid3D([9045,8671,8981,9631],0); -ELEMENTS[16987] = Fluid3D([8981,9045,9631,9910],0); -ELEMENTS[16988] = Fluid3D([8981,9045,9910,9471],0); -ELEMENTS[16989] = Fluid3D([8791,9456,8338,8578],0); -ELEMENTS[16990] = Fluid3D([9456,8338,8578,8537],0); -ELEMENTS[16991] = Fluid3D([8338,8578,8537,7804],0); -ELEMENTS[16992] = Fluid3D([8338,8578,7804,7808],0); -ELEMENTS[16993] = Fluid3D([8537,8338,7804,7741],0); -ELEMENTS[16994] = Fluid3D([8537,8338,7741,8688],0); -ELEMENTS[16995] = Fluid3D([8537,8338,8688,9456],0); -ELEMENTS[16996] = Fluid3D([7741,8537,8688,8741],0); -ELEMENTS[16997] = Fluid3D([8537,8688,8741,9903],0); -ELEMENTS[16998] = Fluid3D([8338,7741,8688,8311],0); -ELEMENTS[16999] = Fluid3D([8688,8338,8311,9045],0); -ELEMENTS[17000] = Fluid3D([8311,8688,9045,9471],0); -ELEMENTS[17001] = Fluid3D([8791,8338,8178,7808],0); -ELEMENTS[17002] = Fluid3D([7741,8537,8741,7969],0); -ELEMENTS[17003] = Fluid3D([7741,8537,7969,7804],0); -ELEMENTS[17004] = Fluid3D([8178,9045,8311,8338],0); -ELEMENTS[17005] = Fluid3D([8537,8741,7969,9242],0); -ELEMENTS[17006] = Fluid3D([8741,7741,7969,7363],0); -ELEMENTS[17007] = Fluid3D([8688,7741,8741,8115],0); -ELEMENTS[17008] = Fluid3D([8741,8688,8115,9085],0); -ELEMENTS[17009] = Fluid3D([7741,8741,8115,7363],0); -ELEMENTS[17010] = Fluid3D([8741,8688,9085,9543],0); -ELEMENTS[17011] = Fluid3D([8741,8688,9543,9903],0); -ELEMENTS[17012] = Fluid3D([9298,9631,8981,8671],0); -ELEMENTS[17013] = Fluid3D([9298,10004,9317,10010],0); -ELEMENTS[17014] = Fluid3D([9774,10004,9298,9761],0); -ELEMENTS[17015] = Fluid3D([11297,10834,11304,11713],0); -ELEMENTS[17016] = Fluid3D([10834,11304,11713,10402],0); -ELEMENTS[17017] = Fluid3D([9317,9631,8671,9484],0); -ELEMENTS[17018] = Fluid3D([9774,9298,8981,8905],0); -ELEMENTS[17019] = Fluid3D([9298,8981,8905,8189],0); -ELEMENTS[17020] = Fluid3D([8981,8905,8189,8348],0); -ELEMENTS[17021] = Fluid3D([8981,8905,8348,9678],0); -ELEMENTS[17022] = Fluid3D([9774,9298,8905,9761],0); -ELEMENTS[17023] = Fluid3D([9298,8981,8189,8671],0); -ELEMENTS[17024] = Fluid3D([8905,8189,8348,7850],0); -ELEMENTS[17025] = Fluid3D([8348,8905,7850,8634],0); -ELEMENTS[17026] = Fluid3D([8905,8189,7850,8509],0); -ELEMENTS[17027] = Fluid3D([8905,8189,8509,9298],0); -ELEMENTS[17028] = Fluid3D([8189,8348,7850,7510],0); -ELEMENTS[17029] = Fluid3D([8189,8348,7510,8311],0); -ELEMENTS[17030] = Fluid3D([7850,8189,7510,7490],0); -ELEMENTS[17031] = Fluid3D([7850,8189,7490,8509],0); -ELEMENTS[17032] = Fluid3D([8189,7510,7490,7456],0); -ELEMENTS[17033] = Fluid3D([7510,7490,7456,6768],0); -ELEMENTS[17034] = Fluid3D([7510,7490,6768,7030],0); -ELEMENTS[17035] = Fluid3D([7510,7490,7030,7850],0); -ELEMENTS[17036] = Fluid3D([8189,7510,7456,8178],0); -ELEMENTS[17037] = Fluid3D([8348,8905,8634,9678],0); -ELEMENTS[17038] = Fluid3D([8905,7850,8634,8573],0); -ELEMENTS[17039] = Fluid3D([8905,7850,8573,8509],0); -ELEMENTS[17040] = Fluid3D([8634,8905,8573,9902],0); -ELEMENTS[17041] = Fluid3D([7850,8634,8573,8065],0); -ELEMENTS[17042] = Fluid3D([10256,11297,11187,10629],0); -ELEMENTS[17043] = Fluid3D([8981,9774,8905,9678],0); -ELEMENTS[17044] = Fluid3D([8348,7850,7510,7776],0); -ELEMENTS[17045] = Fluid3D([10834,10256,10402,9484],0); -ELEMENTS[17046] = Fluid3D([8205,7769,7808,6919],0); -ELEMENTS[17047] = Fluid3D([7808,8582,8704,8578],0); -ELEMENTS[17048] = Fluid3D([4590,4258,4327,4044],0); -ELEMENTS[17049] = Fluid3D([7808,8704,7848,8791],0); -ELEMENTS[17050] = Fluid3D([8364,8883,9235,9341],0); -ELEMENTS[17051] = Fluid3D([5514,5919,5676,6282],0); -ELEMENTS[17052] = Fluid3D([5871,6030,5392,5416],0); -ELEMENTS[17053] = Fluid3D([6468,6277,6968,6900],0); -ELEMENTS[17054] = Fluid3D([5690,6014,5448,5582],0); -ELEMENTS[17055] = Fluid3D([5448,5690,5582,5112],0); -ELEMENTS[17056] = Fluid3D([6014,5448,5582,5477],0); -ELEMENTS[17057] = Fluid3D([5448,5582,5477,5006],0); -ELEMENTS[17058] = Fluid3D([5582,5477,5006,5323],0); -ELEMENTS[17059] = Fluid3D([5582,5477,5323,5953],0); -ELEMENTS[17060] = Fluid3D([5582,5477,5953,6362],0); -ELEMENTS[17061] = Fluid3D([5477,5323,5953,5929],0); -ELEMENTS[17062] = Fluid3D([5323,5582,5953,5828],0); -ELEMENTS[17063] = Fluid3D([5953,5477,5929,6362],0); -ELEMENTS[17064] = Fluid3D([5477,5006,5323,4718],0); -ELEMENTS[17065] = Fluid3D([5006,5582,5323,5076],0); -ELEMENTS[17066] = Fluid3D([5006,5582,5076,5112],0); -ELEMENTS[17067] = Fluid3D([5323,5006,5076,4643],0); -ELEMENTS[17068] = Fluid3D([5006,5076,4643,4636],0); -ELEMENTS[17069] = Fluid3D([4643,5006,4636,4578],0); -ELEMENTS[17070] = Fluid3D([4643,5006,4578,4718],0); -ELEMENTS[17071] = Fluid3D([5006,5076,4636,5112],0); -ELEMENTS[17072] = Fluid3D([5076,4636,5112,4369],0); -ELEMENTS[17073] = Fluid3D([4636,5006,5112,4820],0); -ELEMENTS[17074] = Fluid3D([5112,4636,4820,4494],0); -ELEMENTS[17075] = Fluid3D([5112,4636,4494,4521],0); -ELEMENTS[17076] = Fluid3D([4494,5112,4521,4542],0); -ELEMENTS[17077] = Fluid3D([4521,4494,4542,3805],0); -ELEMENTS[17078] = Fluid3D([4636,4494,4521,4369],0); -ELEMENTS[17079] = Fluid3D([4636,4820,4494,4275],0); -ELEMENTS[17080] = Fluid3D([5006,4636,4578,4820],0); -ELEMENTS[17081] = Fluid3D([4636,4578,4820,4275],0); -ELEMENTS[17082] = Fluid3D([4578,4820,4275,4676],0); -ELEMENTS[17083] = Fluid3D([4275,4578,4676,4111],0); -ELEMENTS[17084] = Fluid3D([4275,4578,4111,4137],0); -ELEMENTS[17085] = Fluid3D([4275,4578,4137,4369],0); -ELEMENTS[17086] = Fluid3D([4636,4578,4275,4369],0); -ELEMENTS[17087] = Fluid3D([4578,4820,4676,5023],0); -ELEMENTS[17088] = Fluid3D([5112,4636,4521,4369],0); -ELEMENTS[17089] = Fluid3D([4578,4820,5023,5006],0); -ELEMENTS[17090] = Fluid3D([4494,4636,4275,4369],0); -ELEMENTS[17091] = Fluid3D([4578,4676,4111,4600],0); -ELEMENTS[17092] = Fluid3D([4676,4578,5023,4600],0); -ELEMENTS[17093] = Fluid3D([4578,5023,4600,5178],0); -ELEMENTS[17094] = Fluid3D([5023,4600,5178,5119],0); -ELEMENTS[17095] = Fluid3D([5178,5023,5119,5601],0); -ELEMENTS[17096] = Fluid3D([5178,5023,5601,5448],0); -ELEMENTS[17097] = Fluid3D([5023,5601,5448,5417],0); -ELEMENTS[17098] = Fluid3D([5023,5119,5601,5314],0); -ELEMENTS[17099] = Fluid3D([4578,4111,4137,4371],0); -ELEMENTS[17100] = Fluid3D([4643,5006,4718,5323],0); -ELEMENTS[17101] = Fluid3D([5023,5119,5314,4676],0); -ELEMENTS[17102] = Fluid3D([4111,4578,4600,4371],0); -ELEMENTS[17103] = Fluid3D([4676,4275,4111,4012],0); -ELEMENTS[17104] = Fluid3D([4111,4275,4137,3797],0); -ELEMENTS[17105] = Fluid3D([5023,4600,5119,4676],0); -ELEMENTS[17106] = Fluid3D([5601,5023,5314,5417],0); -ELEMENTS[17107] = Fluid3D([4137,4578,4371,4643],0); -ELEMENTS[17108] = Fluid3D([4137,4578,4643,4369],0); -ELEMENTS[17109] = Fluid3D([4275,4137,3797,3890],0); -ELEMENTS[17110] = Fluid3D([4275,4111,4012,3797],0); -ELEMENTS[17111] = Fluid3D([4636,4643,4578,4369],0); -ELEMENTS[17112] = Fluid3D([4636,4643,4369,5076],0); -ELEMENTS[17113] = Fluid3D([4578,4600,4371,4718],0); -ELEMENTS[17114] = Fluid3D([4371,4578,4718,4643],0); -ELEMENTS[17115] = Fluid3D([4718,4371,4643,4466],0); -ELEMENTS[17116] = Fluid3D([4820,5112,4494,4816],0); -ELEMENTS[17117] = Fluid3D([5119,5178,5601,5588],0); -ELEMENTS[17118] = Fluid3D([5178,5601,5588,5783],0); -ELEMENTS[17119] = Fluid3D([4676,4275,4012,4405],0); -ELEMENTS[17120] = Fluid3D([4676,4275,4405,4820],0); -ELEMENTS[17121] = Fluid3D([5178,5023,5448,5006],0); -ELEMENTS[17122] = Fluid3D([5588,5178,5783,5383],0); -ELEMENTS[17123] = Fluid3D([5783,5588,5383,6063],0); -ELEMENTS[17124] = Fluid3D([5588,5178,5383,5119],0); -ELEMENTS[17125] = Fluid3D([4275,4012,4405,3954],0); -ELEMENTS[17126] = Fluid3D([4275,4012,3954,3797],0); -ELEMENTS[17127] = Fluid3D([4820,4676,5023,5014],0); -ELEMENTS[17128] = Fluid3D([5023,4820,5014,5448],0); -ELEMENTS[17129] = Fluid3D([5023,4820,5448,5006],0); -ELEMENTS[17130] = Fluid3D([4111,4137,4371,3854],0); -ELEMENTS[17131] = Fluid3D([4820,4676,5014,4405],0); -ELEMENTS[17132] = Fluid3D([5582,5323,5076,5828],0); -ELEMENTS[17133] = Fluid3D([4643,4137,4369,4269],0); -ELEMENTS[17134] = Fluid3D([4676,4111,4600,4234],0); -ELEMENTS[17135] = Fluid3D([4600,4676,4234,4826],0); -ELEMENTS[17136] = Fluid3D([4600,4676,4826,5119],0); -ELEMENTS[17137] = Fluid3D([4826,4600,5119,4658],0); -ELEMENTS[17138] = Fluid3D([5119,4826,4658,5092],0); -ELEMENTS[17139] = Fluid3D([5119,4826,5092,5314],0); -ELEMENTS[17140] = Fluid3D([5119,4826,5314,4676],0); -ELEMENTS[17141] = Fluid3D([4826,4658,5092,4509],0); -ELEMENTS[17142] = Fluid3D([4658,5119,5092,5220],0); -ELEMENTS[17143] = Fluid3D([5092,4826,4509,4921],0); -ELEMENTS[17144] = Fluid3D([5092,4826,4921,5314],0); -ELEMENTS[17145] = Fluid3D([4826,4658,4509,4234],0); -ELEMENTS[17146] = Fluid3D([5119,5092,5220,5644],0); -ELEMENTS[17147] = Fluid3D([5119,5092,5644,5314],0); -ELEMENTS[17148] = Fluid3D([4658,5119,5220,4942],0); -ELEMENTS[17149] = Fluid3D([4658,5119,4942,4600],0); -ELEMENTS[17150] = Fluid3D([4826,4509,4921,4408],0); -ELEMENTS[17151] = Fluid3D([5220,5119,5644,5588],0); -ELEMENTS[17152] = Fluid3D([5119,5644,5588,5601],0); -ELEMENTS[17153] = Fluid3D([4826,4509,4408,4234],0); -ELEMENTS[17154] = Fluid3D([4408,4826,4234,4676],0); -ELEMENTS[17155] = Fluid3D([5644,5220,5588,5874],0); -ELEMENTS[17156] = Fluid3D([5588,5644,5874,6191],0); -ELEMENTS[17157] = Fluid3D([5588,5644,6191,5601],0); -ELEMENTS[17158] = Fluid3D([5119,5220,4942,5383],0); -ELEMENTS[17159] = Fluid3D([5220,5119,5588,5383],0); -ELEMENTS[17160] = Fluid3D([4826,4600,4658,4234],0); -ELEMENTS[17161] = Fluid3D([5220,5588,5874,5564],0); -ELEMENTS[17162] = Fluid3D([5588,5220,5383,5564],0); -ELEMENTS[17163] = Fluid3D([4921,4826,4408,4905],0); -ELEMENTS[17164] = Fluid3D([4921,4826,4905,5314],0); -ELEMENTS[17165] = Fluid3D([4826,4905,5314,5014],0); -ELEMENTS[17166] = Fluid3D([4905,5314,5014,5417],0); -ELEMENTS[17167] = Fluid3D([5314,5014,5417,5023],0); -ELEMENTS[17168] = Fluid3D([5014,4905,5417,5038],0); -ELEMENTS[17169] = Fluid3D([4905,5314,5417,5361],0); -ELEMENTS[17170] = Fluid3D([5314,5417,5361,5852],0); -ELEMENTS[17171] = Fluid3D([5314,5417,5852,5601],0); -ELEMENTS[17172] = Fluid3D([4905,5314,5361,4921],0); -ELEMENTS[17173] = Fluid3D([5314,5014,5023,4676],0); -ELEMENTS[17174] = Fluid3D([4826,4905,5014,4676],0); -ELEMENTS[17175] = Fluid3D([4905,5014,4676,4405],0); -ELEMENTS[17176] = Fluid3D([5314,4826,5014,4676],0); -ELEMENTS[17177] = Fluid3D([5417,4905,5361,5489],0); -ELEMENTS[17178] = Fluid3D([5417,5014,5038,5328],0); -ELEMENTS[17179] = Fluid3D([5417,5014,5328,5448],0); -ELEMENTS[17180] = Fluid3D([5361,5314,5852,5644],0); -ELEMENTS[17181] = Fluid3D([5361,4905,4921,4899],0); -ELEMENTS[17182] = Fluid3D([4921,5361,4899,5235],0); -ELEMENTS[17183] = Fluid3D([4921,5361,5235,5456],0); -ELEMENTS[17184] = Fluid3D([4921,5361,5456,5092],0); -ELEMENTS[17185] = Fluid3D([5417,5361,5852,5489],0); -ELEMENTS[17186] = Fluid3D([5456,4921,5092,4971],0); -ELEMENTS[17187] = Fluid3D([5092,5456,4971,5432],0); -ELEMENTS[17188] = Fluid3D([5092,5456,5432,5644],0); -ELEMENTS[17189] = Fluid3D([5014,4905,5038,4405],0); -ELEMENTS[17190] = Fluid3D([5361,4905,4899,5489],0); -ELEMENTS[17191] = Fluid3D([5361,4899,5235,5470],0); -ELEMENTS[17192] = Fluid3D([5361,5235,5456,5848],0); -ELEMENTS[17193] = Fluid3D([5456,4921,4971,5235],0); -ELEMENTS[17194] = Fluid3D([5235,5361,5470,5848],0); -ELEMENTS[17195] = Fluid3D([4899,4921,5235,4630],0); -ELEMENTS[17196] = Fluid3D([5456,5361,5848,5852],0); -ELEMENTS[17197] = Fluid3D([5361,4899,5470,5489],0); -ELEMENTS[17198] = Fluid3D([5470,5361,5489,5848],0); -ELEMENTS[17199] = Fluid3D([4921,5235,4630,4971],0); -ELEMENTS[17200] = Fluid3D([4921,5092,4971,4509],0); -ELEMENTS[17201] = Fluid3D([4971,5092,5432,4859],0); -ELEMENTS[17202] = Fluid3D([4905,4921,4899,4408],0); -ELEMENTS[17203] = Fluid3D([5092,5432,4859,5220],0); -ELEMENTS[17204] = Fluid3D([4971,5092,4859,4509],0); -ELEMENTS[17205] = Fluid3D([5456,4971,5432,5531],0); -ELEMENTS[17206] = Fluid3D([5456,4971,5531,5235],0); -ELEMENTS[17207] = Fluid3D([5432,5456,5531,5928],0); -ELEMENTS[17208] = Fluid3D([5432,5456,5928,5644],0); -ELEMENTS[17209] = Fluid3D([4899,4921,4630,4408],0); -ELEMENTS[17210] = Fluid3D([5874,5588,6191,6063],0); -ELEMENTS[17211] = Fluid3D([5456,5531,5928,5848],0); -ELEMENTS[17212] = Fluid3D([4658,5092,4509,4859],0); -ELEMENTS[17213] = Fluid3D([4111,4600,4234,4118],0); -ELEMENTS[17214] = Fluid3D([4111,4600,4118,4371],0); -ELEMENTS[17215] = Fluid3D([4600,4234,4118,4658],0); -ELEMENTS[17216] = Fluid3D([5432,4971,4859,5110],0); -ELEMENTS[17217] = Fluid3D([4859,5432,5110,5299],0); -ELEMENTS[17218] = Fluid3D([4859,5432,5299,5220],0); -ELEMENTS[17219] = Fluid3D([4971,4859,5110,4532],0); -ELEMENTS[17220] = Fluid3D([5644,5874,6191,6228],0); -ELEMENTS[17221] = Fluid3D([6191,5644,6228,6173],0); -ELEMENTS[17222] = Fluid3D([6191,5644,6173,5601],0); -ELEMENTS[17223] = Fluid3D([5644,5874,6228,5432],0); -ELEMENTS[17224] = Fluid3D([5092,4658,5220,4859],0); -ELEMENTS[17225] = Fluid3D([5644,5220,5874,5432],0); -ELEMENTS[17226] = Fluid3D([5644,6228,6173,5928],0); -ELEMENTS[17227] = Fluid3D([5874,5588,6063,5564],0); -ELEMENTS[17228] = Fluid3D([6063,5874,5564,6178],0); -ELEMENTS[17229] = Fluid3D([6063,5874,6178,6533],0); -ELEMENTS[17230] = Fluid3D([5874,6178,6533,6228],0); -ELEMENTS[17231] = Fluid3D([5874,5564,6178,5656],0); -ELEMENTS[17232] = Fluid3D([6178,5874,5656,6228],0); -ELEMENTS[17233] = Fluid3D([6063,5874,6533,6191],0); -ELEMENTS[17234] = Fluid3D([5874,6533,6191,6228],0); -ELEMENTS[17235] = Fluid3D([6533,6191,6228,6894],0); -ELEMENTS[17236] = Fluid3D([6533,6191,6894,7158],0); -ELEMENTS[17237] = Fluid3D([5874,5564,5656,5220],0); -ELEMENTS[17238] = Fluid3D([6178,6063,6533,6908],0); -ELEMENTS[17239] = Fluid3D([5564,6178,5656,5809],0); -ELEMENTS[17240] = Fluid3D([6191,6228,6894,6173],0); -ELEMENTS[17241] = Fluid3D([6533,6178,6908,7185],0); -ELEMENTS[17242] = Fluid3D([5220,4658,4942,4769],0); -ELEMENTS[17243] = Fluid3D([4658,4942,4769,4422],0); -ELEMENTS[17244] = Fluid3D([5220,4658,4769,4859],0); -ELEMENTS[17245] = Fluid3D([4942,4769,4422,5035],0); -ELEMENTS[17246] = Fluid3D([4942,4769,5035,5220],0); -ELEMENTS[17247] = Fluid3D([4658,4942,4422,4600],0); -ELEMENTS[17248] = Fluid3D([4769,4658,4422,4290],0); -ELEMENTS[17249] = Fluid3D([4769,4658,4290,4859],0); -ELEMENTS[17250] = Fluid3D([4658,4422,4290,4118],0); -ELEMENTS[17251] = Fluid3D([4658,4422,4118,4600],0); -ELEMENTS[17252] = Fluid3D([4422,4118,4600,4371],0); -ELEMENTS[17253] = Fluid3D([4422,4290,4118,3933],0); -ELEMENTS[17254] = Fluid3D([4118,4422,3933,4295],0); -ELEMENTS[17255] = Fluid3D([4422,4290,3933,4769],0); -ELEMENTS[17256] = Fluid3D([4111,4676,4012,4234],0); -ELEMENTS[17257] = Fluid3D([4137,4371,3854,4104],0); -ELEMENTS[17258] = Fluid3D([4137,4371,4104,4643],0); -ELEMENTS[17259] = Fluid3D([4371,3854,4104,4295],0); -ELEMENTS[17260] = Fluid3D([4104,4371,4295,4466],0); -ELEMENTS[17261] = Fluid3D([4295,4104,4466,4202],0); -ELEMENTS[17262] = Fluid3D([4826,4408,4905,4676],0); -ELEMENTS[17263] = Fluid3D([4012,4676,4405,4408],0); -ELEMENTS[17264] = Fluid3D([5235,5456,5848,5531],0); -ELEMENTS[17265] = Fluid3D([5092,5220,5644,5432],0); -ELEMENTS[17266] = Fluid3D([4820,4494,4275,4405],0); -ELEMENTS[17267] = Fluid3D([4494,4275,4405,3954],0); -ELEMENTS[17268] = Fluid3D([5531,5432,5928,5863],0); -ELEMENTS[17269] = Fluid3D([5432,5928,5863,6028],0); -ELEMENTS[17270] = Fluid3D([5432,5928,6028,6228],0); -ELEMENTS[17271] = Fluid3D([5928,6028,6228,6521],0); -ELEMENTS[17272] = Fluid3D([5928,6028,6521,5863],0); -ELEMENTS[17273] = Fluid3D([6521,5928,5863,6229],0); -ELEMENTS[17274] = Fluid3D([6521,5928,6229,7114],0); -ELEMENTS[17275] = Fluid3D([6228,5928,6521,6726],0); -ELEMENTS[17276] = Fluid3D([5928,6521,6726,7114],0); -ELEMENTS[17277] = Fluid3D([6228,5928,6726,6173],0); -ELEMENTS[17278] = Fluid3D([6028,6521,5863,6644],0); -ELEMENTS[17279] = Fluid3D([5531,5432,5863,5110],0); -ELEMENTS[17280] = Fluid3D([4012,4405,3954,3971],0); -ELEMENTS[17281] = Fluid3D([3954,4012,3971,3597],0); -ELEMENTS[17282] = Fluid3D([3954,4012,3597,3797],0); -ELEMENTS[17283] = Fluid3D([4899,5235,5470,5020],0); -ELEMENTS[17284] = Fluid3D([5470,4899,5020,5005],0); -ELEMENTS[17285] = Fluid3D([5470,4899,5005,5489],0); -ELEMENTS[17286] = Fluid3D([5235,5470,5020,5606],0); -ELEMENTS[17287] = Fluid3D([5235,5470,5606,5848],0); -ELEMENTS[17288] = Fluid3D([5020,5470,5005,5590],0); -ELEMENTS[17289] = Fluid3D([5470,5020,5606,5590],0); -ELEMENTS[17290] = Fluid3D([4971,5432,5531,5110],0); -ELEMENTS[17291] = Fluid3D([5119,5601,5314,5644],0); -ELEMENTS[17292] = Fluid3D([4509,4921,4408,4630],0); -ELEMENTS[17293] = Fluid3D([4137,4111,3797,3854],0); -ELEMENTS[17294] = Fluid3D([4371,4111,3854,4118],0); -ELEMENTS[17295] = Fluid3D([5235,4899,4630,5020],0); -ELEMENTS[17296] = Fluid3D([4859,5110,4532,4689],0); -ELEMENTS[17297] = Fluid3D([4859,5110,4689,5299],0); -ELEMENTS[17298] = Fluid3D([5690,6014,5582,6174],0); -ELEMENTS[17299] = Fluid3D([5110,4532,4689,4680],0); -ELEMENTS[17300] = Fluid3D([4371,3854,4295,4118],0); -ELEMENTS[17301] = Fluid3D([5588,5383,6063,5564],0); -ELEMENTS[17302] = Fluid3D([5448,5582,5006,5112],0); -ELEMENTS[17303] = Fluid3D([5314,5361,4921,5092],0); -ELEMENTS[17304] = Fluid3D([6228,6533,6894,6979],0); -ELEMENTS[17305] = Fluid3D([6533,6894,6979,7410],0); -ELEMENTS[17306] = Fluid3D([6533,6894,7410,7158],0); -ELEMENTS[17307] = Fluid3D([6894,7410,7158,8089],0); -ELEMENTS[17308] = Fluid3D([6979,6533,7410,7185],0); -ELEMENTS[17309] = Fluid3D([6894,6979,7410,7652],0); -ELEMENTS[17310] = Fluid3D([7410,6894,7652,8089],0); -ELEMENTS[17311] = Fluid3D([6894,6979,7652,7161],0); -ELEMENTS[17312] = Fluid3D([6979,7652,7161,7853],0); -ELEMENTS[17313] = Fluid3D([6979,7410,7652,7889],0); -ELEMENTS[17314] = Fluid3D([4509,4408,4234,4007],0); -ELEMENTS[17315] = Fluid3D([4408,4234,4007,4012],0); -ELEMENTS[17316] = Fluid3D([4509,4408,4007,4630],0); -ELEMENTS[17317] = Fluid3D([3854,4137,4104,3730],0); -ELEMENTS[17318] = Fluid3D([4137,4104,3730,4269],0); -ELEMENTS[17319] = Fluid3D([3854,4137,3730,3797],0); -ELEMENTS[17320] = Fluid3D([4104,3854,3730,3661],0); -ELEMENTS[17321] = Fluid3D([3730,4104,3661,3916],0); -ELEMENTS[17322] = Fluid3D([4104,3661,3916,4202],0); -ELEMENTS[17323] = Fluid3D([4104,3854,3661,4295],0); -ELEMENTS[17324] = Fluid3D([3854,3730,3661,3414],0); -ELEMENTS[17325] = Fluid3D([3730,3661,3414,3327],0); -ELEMENTS[17326] = Fluid3D([3854,3730,3414,3797],0); -ELEMENTS[17327] = Fluid3D([3661,3854,3414,3554],0); -ELEMENTS[17328] = Fluid3D([3414,3661,3554,3180],0); -ELEMENTS[17329] = Fluid3D([3661,3854,3554,4295],0); -ELEMENTS[17330] = Fluid3D([3854,3414,3554,3547],0); -ELEMENTS[17331] = Fluid3D([3414,3554,3547,3164],0); -ELEMENTS[17332] = Fluid3D([3854,3414,3547,3797],0); -ELEMENTS[17333] = Fluid3D([3554,3547,3164,3433],0); -ELEMENTS[17334] = Fluid3D([3164,3554,3433,3236],0); -ELEMENTS[17335] = Fluid3D([3554,3854,3547,4118],0); -ELEMENTS[17336] = Fluid3D([3433,3164,3236,3002],0); -ELEMENTS[17337] = Fluid3D([3164,3554,3236,3180],0); -ELEMENTS[17338] = Fluid3D([3554,3547,3433,4118],0); -ELEMENTS[17339] = Fluid3D([3414,3554,3164,3180],0); -ELEMENTS[17340] = Fluid3D([3547,3414,3164,3202],0); -ELEMENTS[17341] = Fluid3D([3547,3414,3202,3797],0); -ELEMENTS[17342] = Fluid3D([3414,3164,3202,3136],0); -ELEMENTS[17343] = Fluid3D([3414,3164,3136,3180],0); -ELEMENTS[17344] = Fluid3D([3202,3414,3136,3182],0); -ELEMENTS[17345] = Fluid3D([3414,3136,3182,3327],0); -ELEMENTS[17346] = Fluid3D([3414,3136,3327,3180],0); -ELEMENTS[17347] = Fluid3D([3202,3414,3182,3797],0); -ELEMENTS[17348] = Fluid3D([3164,3547,3202,3205],0); -ELEMENTS[17349] = Fluid3D([3547,3202,3205,3466],0); -ELEMENTS[17350] = Fluid3D([3547,3202,3466,3797],0); -ELEMENTS[17351] = Fluid3D([3202,3205,3466,3056],0); -ELEMENTS[17352] = Fluid3D([3202,3205,3056,2871],0); -ELEMENTS[17353] = Fluid3D([3466,3202,3056,3248],0); -ELEMENTS[17354] = Fluid3D([3466,3202,3248,3797],0); -ELEMENTS[17355] = Fluid3D([3164,3547,3205,3433],0); -ELEMENTS[17356] = Fluid3D([3202,3205,2871,3164],0); -ELEMENTS[17357] = Fluid3D([3056,3202,2871,2792],0); -ELEMENTS[17358] = Fluid3D([3056,3202,2792,3248],0); -ELEMENTS[17359] = Fluid3D([3202,2871,2792,2912],0); -ELEMENTS[17360] = Fluid3D([3202,2871,2912,3164],0); -ELEMENTS[17361] = Fluid3D([2792,3202,2912,3182],0); -ELEMENTS[17362] = Fluid3D([3202,2912,3182,3136],0); -ELEMENTS[17363] = Fluid3D([2912,3182,3136,3074],0); -ELEMENTS[17364] = Fluid3D([3182,3136,3074,3327],0); -ELEMENTS[17365] = Fluid3D([2912,3182,3074,2828],0); -ELEMENTS[17366] = Fluid3D([3182,3074,2828,3176],0); -ELEMENTS[17367] = Fluid3D([2912,3182,2828,2792],0); -ELEMENTS[17368] = Fluid3D([3205,3466,3056,3344],0); -ELEMENTS[17369] = Fluid3D([3056,3205,3344,2789],0); -ELEMENTS[17370] = Fluid3D([3466,3056,3344,3316],0); -ELEMENTS[17371] = Fluid3D([3056,3344,3316,3000],0); -ELEMENTS[17372] = Fluid3D([3205,3466,3344,3570],0); -ELEMENTS[17373] = Fluid3D([3205,3466,3570,3547],0); -ELEMENTS[17374] = Fluid3D([3466,3344,3570,3696],0); -ELEMENTS[17375] = Fluid3D([3570,3466,3696,3909],0); -ELEMENTS[17376] = Fluid3D([3570,3466,3909,3547],0); -ELEMENTS[17377] = Fluid3D([3466,3344,3696,3316],0); -ELEMENTS[17378] = Fluid3D([3466,3056,3316,3248],0); -ELEMENTS[17379] = Fluid3D([2871,2792,2912,2609],0); -ELEMENTS[17380] = Fluid3D([2912,2871,2609,2720],0); -ELEMENTS[17381] = Fluid3D([2871,2792,2609,2504],0); -ELEMENTS[17382] = Fluid3D([2792,2912,2609,2828],0); -ELEMENTS[17383] = Fluid3D([2912,2871,2720,3164],0); -ELEMENTS[17384] = Fluid3D([3344,3205,3570,3104],0); -ELEMENTS[17385] = Fluid3D([3344,3205,3104,2789],0); -ELEMENTS[17386] = Fluid3D([2609,2912,2720,2577],0); -ELEMENTS[17387] = Fluid3D([2912,2720,2577,2932],0); -ELEMENTS[17388] = Fluid3D([2609,2912,2577,2828],0); -ELEMENTS[17389] = Fluid3D([2720,2609,2577,2423],0); -ELEMENTS[17390] = Fluid3D([3205,3056,2871,2789],0); -ELEMENTS[17391] = Fluid3D([2871,3056,2792,2504],0); -ELEMENTS[17392] = Fluid3D([2871,2609,2720,2586],0); -ELEMENTS[17393] = Fluid3D([2871,2609,2586,2504],0); -ELEMENTS[17394] = Fluid3D([2720,2871,2586,2692],0); -ELEMENTS[17395] = Fluid3D([3554,3433,3236,3651],0); -ELEMENTS[17396] = Fluid3D([3554,3433,3651,3933],0); -ELEMENTS[17397] = Fluid3D([3236,3554,3651,3517],0); -ELEMENTS[17398] = Fluid3D([3554,3651,3517,3940],0); -ELEMENTS[17399] = Fluid3D([3554,3651,3940,3933],0); -ELEMENTS[17400] = Fluid3D([3433,3236,3651,3363],0); -ELEMENTS[17401] = Fluid3D([3236,3651,3363,3386],0); -ELEMENTS[17402] = Fluid3D([3236,3651,3386,3517],0); -ELEMENTS[17403] = Fluid3D([3651,3940,3933,4025],0); -ELEMENTS[17404] = Fluid3D([3933,3651,4025,3837],0); -ELEMENTS[17405] = Fluid3D([3933,3651,3837,3433],0); -ELEMENTS[17406] = Fluid3D([3651,4025,3837,3386],0); -ELEMENTS[17407] = Fluid3D([4025,3933,3837,4280],0); -ELEMENTS[17408] = Fluid3D([3933,3837,4280,4290],0); -ELEMENTS[17409] = Fluid3D([3651,3940,4025,3768],0); -ELEMENTS[17410] = Fluid3D([4025,3933,4280,4429],0); -ELEMENTS[17411] = Fluid3D([3933,4280,4429,4422],0); -ELEMENTS[17412] = Fluid3D([4429,3933,4422,4295],0); -ELEMENTS[17413] = Fluid3D([4280,4025,4429,4745],0); -ELEMENTS[17414] = Fluid3D([4025,3933,4429,3940],0); -ELEMENTS[17415] = Fluid3D([3651,3517,3940,3768],0); -ELEMENTS[17416] = Fluid3D([3517,3940,3768,3559],0); -ELEMENTS[17417] = Fluid3D([3768,3517,3559,3355],0); -ELEMENTS[17418] = Fluid3D([3651,3363,3386,3837],0); -ELEMENTS[17419] = Fluid3D([3433,3236,3363,3002],0); -ELEMENTS[17420] = Fluid3D([3236,3554,3517,3180],0); -ELEMENTS[17421] = Fluid3D([3651,3433,3363,3837],0); -ELEMENTS[17422] = Fluid3D([3837,4025,4280,4281],0); -ELEMENTS[17423] = Fluid3D([3517,3554,3940,3661],0); -ELEMENTS[17424] = Fluid3D([3344,3570,3696,3476],0); -ELEMENTS[17425] = Fluid3D([5432,5110,5299,5863],0); -ELEMENTS[17426] = Fluid3D([5110,4971,4532,4906],0); -ELEMENTS[17427] = Fluid3D([4971,4532,4906,4493],0); -ELEMENTS[17428] = Fluid3D([5110,4971,4906,5531],0); -ELEMENTS[17429] = Fluid3D([4532,4906,4493,4198],0); -ELEMENTS[17430] = Fluid3D([4493,4532,4198,4083],0); -ELEMENTS[17431] = Fluid3D([4532,4198,4083,3888],0); -ELEMENTS[17432] = Fluid3D([4198,4083,3888,3755],0); -ELEMENTS[17433] = Fluid3D([4083,3888,3755,3476],0); -ELEMENTS[17434] = Fluid3D([4493,4532,4083,4509],0); -ELEMENTS[17435] = Fluid3D([4532,5110,4906,4680],0); -ELEMENTS[17436] = Fluid3D([4906,4532,4680,4198],0); -ELEMENTS[17437] = Fluid3D([5110,4906,4680,5296],0); -ELEMENTS[17438] = Fluid3D([4906,4680,5296,5070],0); -ELEMENTS[17439] = Fluid3D([5110,4906,5296,5531],0); -ELEMENTS[17440] = Fluid3D([4680,5296,5070,5241],0); -ELEMENTS[17441] = Fluid3D([5296,5070,5241,5649],0); -ELEMENTS[17442] = Fluid3D([4680,5296,5241,4874],0); -ELEMENTS[17443] = Fluid3D([4198,4493,4083,3755],0); -ELEMENTS[17444] = Fluid3D([4971,4532,4493,4509],0); -ELEMENTS[17445] = Fluid3D([4906,4971,4493,5036],0); -ELEMENTS[17446] = Fluid3D([4906,4971,5036,5531],0); -ELEMENTS[17447] = Fluid3D([4971,4493,5036,4630],0); -ELEMENTS[17448] = Fluid3D([4493,5036,4630,4614],0); -ELEMENTS[17449] = Fluid3D([4630,4493,4614,4134],0); -ELEMENTS[17450] = Fluid3D([4630,4493,4134,4007],0); -ELEMENTS[17451] = Fluid3D([5036,4630,4614,5020],0); -ELEMENTS[17452] = Fluid3D([4614,4630,4134,4464],0); -ELEMENTS[17453] = Fluid3D([4614,4630,4464,5020],0); -ELEMENTS[17454] = Fluid3D([4630,4134,4464,4311],0); -ELEMENTS[17455] = Fluid3D([4630,4134,4311,4007],0); -ELEMENTS[17456] = Fluid3D([4493,4614,4134,4045],0); -ELEMENTS[17457] = Fluid3D([4614,4134,4045,3930],0); -ELEMENTS[17458] = Fluid3D([4464,4630,4311,4899],0); -ELEMENTS[17459] = Fluid3D([4971,4493,4630,4509],0); -ELEMENTS[17460] = Fluid3D([4493,5036,4614,4906],0); -ELEMENTS[17461] = Fluid3D([4134,4464,4311,3959],0); -ELEMENTS[17462] = Fluid3D([4311,4134,3959,3828],0); -ELEMENTS[17463] = Fluid3D([4311,4134,3828,4007],0); -ELEMENTS[17464] = Fluid3D([4134,4614,4464,3930],0); -ELEMENTS[17465] = Fluid3D([4134,4464,3959,3930],0); -ELEMENTS[17466] = Fluid3D([4134,3959,3828,3632],0); -ELEMENTS[17467] = Fluid3D([3959,4311,3828,3914],0); -ELEMENTS[17468] = Fluid3D([4311,3828,3914,4056],0); -ELEMENTS[17469] = Fluid3D([4464,4311,3959,4302],0); -ELEMENTS[17470] = Fluid3D([3914,4311,4056,4385],0); -ELEMENTS[17471] = Fluid3D([4311,3828,4056,4007],0); -ELEMENTS[17472] = Fluid3D([3828,4056,4007,3696],0); -ELEMENTS[17473] = Fluid3D([3828,4056,3696,3914],0); -ELEMENTS[17474] = Fluid3D([4007,3828,3696,3358],0); -ELEMENTS[17475] = Fluid3D([4056,4007,3696,4012],0); -ELEMENTS[17476] = Fluid3D([3696,4056,4012,3971],0); -ELEMENTS[17477] = Fluid3D([4056,4012,3971,4405],0); -ELEMENTS[17478] = Fluid3D([3959,4311,3914,4302],0); -ELEMENTS[17479] = Fluid3D([3914,4311,4385,4302],0); -ELEMENTS[17480] = Fluid3D([3828,3959,3914,3535],0); -ELEMENTS[17481] = Fluid3D([3959,3914,3535,3787],0); -ELEMENTS[17482] = Fluid3D([3959,3914,3787,4302],0); -ELEMENTS[17483] = Fluid3D([4056,3914,4385,3971],0); -ELEMENTS[17484] = Fluid3D([3914,4385,3971,4047],0); -ELEMENTS[17485] = Fluid3D([4056,3914,3971,3696],0); -ELEMENTS[17486] = Fluid3D([4385,4056,3971,4405],0); -ELEMENTS[17487] = Fluid3D([3971,4385,4405,4212],0); -ELEMENTS[17488] = Fluid3D([4405,3971,4212,3954],0); -ELEMENTS[17489] = Fluid3D([4212,4405,3954,4494],0); -ELEMENTS[17490] = Fluid3D([3971,4212,3954,3751],0); -ELEMENTS[17491] = Fluid3D([4212,3954,3751,3805],0); -ELEMENTS[17492] = Fluid3D([3971,4212,3751,4047],0); -ELEMENTS[17493] = Fluid3D([4212,4405,4494,4816],0); -ELEMENTS[17494] = Fluid3D([3954,3751,3805,3597],0); -ELEMENTS[17495] = Fluid3D([4385,4405,4212,4550],0); -ELEMENTS[17496] = Fluid3D([4385,4405,4550,5038],0); -ELEMENTS[17497] = Fluid3D([4405,4212,4550,4816],0); -ELEMENTS[17498] = Fluid3D([3954,3971,3751,3597],0); -ELEMENTS[17499] = Fluid3D([3971,4385,4212,4047],0); -ELEMENTS[17500] = Fluid3D([3914,3535,3787,3537],0); -ELEMENTS[17501] = Fluid3D([3914,3535,3537,3316],0); -ELEMENTS[17502] = Fluid3D([3787,3914,3537,4047],0); -ELEMENTS[17503] = Fluid3D([3535,3787,3537,3343],0); -ELEMENTS[17504] = Fluid3D([3537,3535,3343,3162],0); -ELEMENTS[17505] = Fluid3D([3535,3787,3343,3523],0); -ELEMENTS[17506] = Fluid3D([3787,3537,3343,3540],0); -ELEMENTS[17507] = Fluid3D([3537,3343,3540,3188],0); -ELEMENTS[17508] = Fluid3D([3537,3343,3188,3162],0); -ELEMENTS[17509] = Fluid3D([3787,3537,3540,4047],0); -ELEMENTS[17510] = Fluid3D([3537,3535,3162,3316],0); -ELEMENTS[17511] = Fluid3D([3162,3537,3316,3174],0); -ELEMENTS[17512] = Fluid3D([3316,3162,3174,2930],0); -ELEMENTS[17513] = Fluid3D([3316,3162,2930,3000],0); -ELEMENTS[17514] = Fluid3D([3162,3174,2930,2875],0); -ELEMENTS[17515] = Fluid3D([3162,3174,2875,3188],0); -ELEMENTS[17516] = Fluid3D([3174,2875,3188,2971],0); -ELEMENTS[17517] = Fluid3D([3188,3174,2971,3385],0); -ELEMENTS[17518] = Fluid3D([3188,3174,3385,3537],0); -ELEMENTS[17519] = Fluid3D([2930,3162,2875,2900],0); -ELEMENTS[17520] = Fluid3D([3162,2875,2900,3343],0); -ELEMENTS[17521] = Fluid3D([2875,3188,2971,2866],0); -ELEMENTS[17522] = Fluid3D([2875,3188,2866,2836],0); -ELEMENTS[17523] = Fluid3D([2971,3188,3385,3163],0); -ELEMENTS[17524] = Fluid3D([3188,2971,2866,3163],0); -ELEMENTS[17525] = Fluid3D([2930,3162,2900,3000],0); -ELEMENTS[17526] = Fluid3D([3162,3174,3188,3537],0); -ELEMENTS[17527] = Fluid3D([3188,3385,3163,3540],0); -ELEMENTS[17528] = Fluid3D([3174,2971,3385,3144],0); -ELEMENTS[17529] = Fluid3D([3385,3174,3144,3751],0); -ELEMENTS[17530] = Fluid3D([3174,2875,2971,2771],0); -ELEMENTS[17531] = Fluid3D([3174,2971,3144,2771],0); -ELEMENTS[17532] = Fluid3D([3174,3316,2930,3248],0); -ELEMENTS[17533] = Fluid3D([2875,2971,2771,2627],0); -ELEMENTS[17534] = Fluid3D([2875,2971,2627,2866],0); -ELEMENTS[17535] = Fluid3D([2971,2771,2627,2747],0); -ELEMENTS[17536] = Fluid3D([2971,2771,2747,3144],0); -ELEMENTS[17537] = Fluid3D([3385,2971,3163,3137],0); -ELEMENTS[17538] = Fluid3D([2971,3163,3137,2846],0); -ELEMENTS[17539] = Fluid3D([3137,2971,2846,2747],0); -ELEMENTS[17540] = Fluid3D([2971,2846,2747,2627],0); -ELEMENTS[17541] = Fluid3D([2971,3163,2846,2866],0); -ELEMENTS[17542] = Fluid3D([3163,3137,2846,2859],0); -ELEMENTS[17543] = Fluid3D([3163,3385,3137,3509],0); -ELEMENTS[17544] = Fluid3D([3163,3385,3509,3540],0); -ELEMENTS[17545] = Fluid3D([2971,3385,3144,3137],0); -ELEMENTS[17546] = Fluid3D([3162,2900,3000,3242],0); -ELEMENTS[17547] = Fluid3D([3162,2900,3242,3343],0); -ELEMENTS[17548] = Fluid3D([3174,2930,2875,2771],0); -ELEMENTS[17549] = Fluid3D([2930,2875,2771,2697],0); -ELEMENTS[17550] = Fluid3D([2930,2875,2697,2900],0); -ELEMENTS[17551] = Fluid3D([3174,2930,2771,3248],0); -ELEMENTS[17552] = Fluid3D([2771,2930,2697,2792],0); -ELEMENTS[17553] = Fluid3D([2771,2875,2627,2697],0); -ELEMENTS[17554] = Fluid3D([2771,2627,2747,2528],0); -ELEMENTS[17555] = Fluid3D([2771,2627,2528,2433],0); -ELEMENTS[17556] = Fluid3D([2627,2528,2433,2368],0); -ELEMENTS[17557] = Fluid3D([2627,2747,2528,2425],0); -ELEMENTS[17558] = Fluid3D([2747,2528,2425,2550],0); -ELEMENTS[17559] = Fluid3D([2747,2528,2550,2743],0); -ELEMENTS[17560] = Fluid3D([2747,2528,2743,2771],0); -ELEMENTS[17561] = Fluid3D([2627,2747,2425,2846],0); -ELEMENTS[17562] = Fluid3D([3137,3163,3509,3173],0); -ELEMENTS[17563] = Fluid3D([3137,3163,3173,2859],0); -ELEMENTS[17564] = Fluid3D([3163,3509,3173,3434],0); -ELEMENTS[17565] = Fluid3D([3163,3509,3434,3540],0); -ELEMENTS[17566] = Fluid3D([3509,3137,3173,3156],0); -ELEMENTS[17567] = Fluid3D([3509,3173,3434,3590],0); -ELEMENTS[17568] = Fluid3D([3434,3509,3590,3822],0); -ELEMENTS[17569] = Fluid3D([3509,3173,3590,3421],0); -ELEMENTS[17570] = Fluid3D([3509,3173,3421,3156],0); -ELEMENTS[17571] = Fluid3D([3173,3421,3156,3187],0); -ELEMENTS[17572] = Fluid3D([3421,3156,3187,3203],0); -ELEMENTS[17573] = Fluid3D([3173,3421,3187,3590],0); -ELEMENTS[17574] = Fluid3D([3173,3434,3590,3285],0); -ELEMENTS[17575] = Fluid3D([3434,3590,3285,3844],0); -ELEMENTS[17576] = Fluid3D([3173,3434,3285,3041],0); -ELEMENTS[17577] = Fluid3D([3173,3434,3041,3163],0); -ELEMENTS[17578] = Fluid3D([3434,3285,3041,3329],0); -ELEMENTS[17579] = Fluid3D([3434,3285,3329,3844],0); -ELEMENTS[17580] = Fluid3D([3285,3041,3329,3050],0); -ELEMENTS[17581] = Fluid3D([3329,3285,3050,3528],0); -ELEMENTS[17582] = Fluid3D([3434,3509,3822,3540],0); -ELEMENTS[17583] = Fluid3D([3343,3540,3188,3195],0); -ELEMENTS[17584] = Fluid3D([3188,3343,3195,2836],0); -ELEMENTS[17585] = Fluid3D([3343,3540,3195,3550],0); -ELEMENTS[17586] = Fluid3D([3540,3188,3195,3163],0); -ELEMENTS[17587] = Fluid3D([3540,3195,3550,3530],0); -ELEMENTS[17588] = Fluid3D([3540,3195,3530,3163],0); -ELEMENTS[17589] = Fluid3D([3195,3550,3530,3084],0); -ELEMENTS[17590] = Fluid3D([3343,3540,3550,3787],0); -ELEMENTS[17591] = Fluid3D([3195,3343,3550,3152],0); -ELEMENTS[17592] = Fluid3D([3195,3343,3152,2836],0); -ELEMENTS[17593] = Fluid3D([3343,3550,3152,3523],0); -ELEMENTS[17594] = Fluid3D([4212,4385,4550,4047],0); -ELEMENTS[17595] = Fluid3D([4311,4056,4385,4408],0); -ELEMENTS[17596] = Fluid3D([4311,4056,4408,4007],0); -ELEMENTS[17597] = Fluid3D([4056,4408,4007,4012],0); -ELEMENTS[17598] = Fluid3D([4056,4408,4012,4405],0); -ELEMENTS[17599] = Fluid3D([4056,4385,4408,4405],0); -ELEMENTS[17600] = Fluid3D([3914,3828,3535,3696],0); -ELEMENTS[17601] = Fluid3D([3385,3137,3509,3511],0); -ELEMENTS[17602] = Fluid3D([3509,3385,3511,4040],0); -ELEMENTS[17603] = Fluid3D([3385,3137,3511,3144],0); -ELEMENTS[17604] = Fluid3D([3137,3509,3511,3156],0); -ELEMENTS[17605] = Fluid3D([3828,3959,3535,3632],0); -ELEMENTS[17606] = Fluid3D([3535,3959,3787,3523],0); -ELEMENTS[17607] = Fluid3D([3535,3343,3162,3242],0); -ELEMENTS[17608] = Fluid3D([3162,3535,3242,3332],0); -ELEMENTS[17609] = Fluid3D([3535,3242,3332,3632],0); -ELEMENTS[17610] = Fluid3D([3162,3535,3332,3316],0); -ELEMENTS[17611] = Fluid3D([3332,3162,3316,3000],0); -ELEMENTS[17612] = Fluid3D([3316,3332,3000,3344],0); -ELEMENTS[17613] = Fluid3D([3316,3332,3344,3696],0); -ELEMENTS[17614] = Fluid3D([3332,3000,3344,3358],0); -ELEMENTS[17615] = Fluid3D([3344,3332,3358,3696],0); -ELEMENTS[17616] = Fluid3D([3332,3000,3358,3242],0); -ELEMENTS[17617] = Fluid3D([3358,3332,3242,3632],0); -ELEMENTS[17618] = Fluid3D([3316,3332,3696,3535],0); -ELEMENTS[17619] = Fluid3D([3332,3000,3242,3162],0); -ELEMENTS[17620] = Fluid3D([3535,3343,3242,3523],0); -ELEMENTS[17621] = Fluid3D([3332,3358,3696,3828],0); -ELEMENTS[17622] = Fluid3D([3696,3332,3828,3535],0); -ELEMENTS[17623] = Fluid3D([3466,3696,3909,4012],0); -ELEMENTS[17624] = Fluid3D([3696,3909,4012,4007],0); -ELEMENTS[17625] = Fluid3D([3909,3466,4012,3797],0); -ELEMENTS[17626] = Fluid3D([4971,4859,4532,4509],0); -ELEMENTS[17627] = Fluid3D([4234,4111,4118,3909],0); -ELEMENTS[17628] = Fluid3D([4234,4111,3909,4012],0); -ELEMENTS[17629] = Fluid3D([4111,3909,4012,3797],0); -ELEMENTS[17630] = Fluid3D([3909,4234,4012,4007],0); -ELEMENTS[17631] = Fluid3D([3909,4234,4007,3570],0); -ELEMENTS[17632] = Fluid3D([4118,4234,3909,3570],0); -ELEMENTS[17633] = Fluid3D([3041,3434,3329,3239],0); -ELEMENTS[17634] = Fluid3D([3041,3434,3239,3163],0); -ELEMENTS[17635] = Fluid3D([3434,3329,3239,3530],0); -ELEMENTS[17636] = Fluid3D([3329,3041,3239,2988],0); -ELEMENTS[17637] = Fluid3D([3329,3041,2988,3050],0); -ELEMENTS[17638] = Fluid3D([3239,3329,2988,3331],0); -ELEMENTS[17639] = Fluid3D([3239,3329,3331,3530],0); -ELEMENTS[17640] = Fluid3D([3331,3239,3530,3084],0); -ELEMENTS[17641] = Fluid3D([3329,2988,3331,3175],0); -ELEMENTS[17642] = Fluid3D([2988,3331,3175,2981],0); -ELEMENTS[17643] = Fluid3D([3329,2988,3175,3050],0); -ELEMENTS[17644] = Fluid3D([3041,3239,2988,2825],0); -ELEMENTS[17645] = Fluid3D([2988,3239,3331,3020],0); -ELEMENTS[17646] = Fluid3D([3239,3434,3530,3163],0); -ELEMENTS[17647] = Fluid3D([3331,3329,3175,3609],0); -ELEMENTS[17648] = Fluid3D([3331,3329,3609,3812],0); -ELEMENTS[17649] = Fluid3D([3609,3331,3812,3631],0); -ELEMENTS[17650] = Fluid3D([3812,3609,3631,4089],0); -ELEMENTS[17651] = Fluid3D([3812,3609,4089,4169],0); -ELEMENTS[17652] = Fluid3D([3609,3331,3631,3175],0); -ELEMENTS[17653] = Fluid3D([3812,3609,4169,3844],0); -ELEMENTS[17654] = Fluid3D([3329,3175,3609,3482],0); -ELEMENTS[17655] = Fluid3D([6741,6234,6051,6416],0); -ELEMENTS[17656] = Fluid3D([6416,5789,6193,6234],0); -ELEMENTS[17657] = Fluid3D([6063,6533,6908,6746],0); -ELEMENTS[17658] = Fluid3D([6063,6533,6746,6191],0); -ELEMENTS[17659] = Fluid3D([6908,6063,6746,6296],0); -ELEMENTS[17660] = Fluid3D([6813,7110,6919,7767],0); -ELEMENTS[17661] = Fluid3D([5038,5586,5004,4968],0); -ELEMENTS[17662] = Fluid3D([4532,4859,4689,4320],0); -ELEMENTS[17663] = Fluid3D([4532,4859,4320,4509],0); -ELEMENTS[17664] = Fluid3D([4859,4689,4320,4726],0); -ELEMENTS[17665] = Fluid3D([4859,4689,4726,5299],0); -ELEMENTS[17666] = Fluid3D([4320,4859,4726,4290],0); -ELEMENTS[17667] = Fluid3D([4689,4532,4320,4354],0); -ELEMENTS[17668] = Fluid3D([4689,4532,4354,4680],0); -ELEMENTS[17669] = Fluid3D([4320,4689,4354,4041],0); -ELEMENTS[17670] = Fluid3D([4532,4320,4354,3888],0); -ELEMENTS[17671] = Fluid3D([4689,4320,4726,4041],0); -ELEMENTS[17672] = Fluid3D([6030,5690,5392,5398],0); -ELEMENTS[17673] = Fluid3D([7827,7230,7023,7223],0); -ELEMENTS[17674] = Fluid3D([5188,4998,5523,5509],0); -ELEMENTS[17675] = Fluid3D([7827,7023,7704,7312],0); -ELEMENTS[17676] = Fluid3D([7704,7827,7312,8384],0); -ELEMENTS[17677] = Fluid3D([7827,7312,8384,8103],0); -ELEMENTS[17678] = Fluid3D([7827,7023,7312,7223],0); -ELEMENTS[17679] = Fluid3D([7312,7704,8384,7888],0); -ELEMENTS[17680] = Fluid3D([8384,7312,7888,8154],0); -ELEMENTS[17681] = Fluid3D([7312,7888,8154,7283],0); -ELEMENTS[17682] = Fluid3D([7312,7704,7888,6741],0); -ELEMENTS[17683] = Fluid3D([7888,8154,7283,8084],0); -ELEMENTS[17684] = Fluid3D([7888,8154,8084,9044],0); -ELEMENTS[17685] = Fluid3D([8154,7283,8084,7826],0); -ELEMENTS[17686] = Fluid3D([7283,8084,7826,6900],0); -ELEMENTS[17687] = Fluid3D([8154,7283,7826,7644],0); -ELEMENTS[17688] = Fluid3D([7826,8154,7644,8927],0); -ELEMENTS[17689] = Fluid3D([7283,7826,7644,6900],0); -ELEMENTS[17690] = Fluid3D([7312,7888,7283,6741],0); -ELEMENTS[17691] = Fluid3D([7704,8384,7888,8604],0); -ELEMENTS[17692] = Fluid3D([8384,7888,8604,8154],0); -ELEMENTS[17693] = Fluid3D([7283,7888,8084,6968],0); -ELEMENTS[17694] = Fluid3D([8384,7312,8154,8103],0); -ELEMENTS[17695] = Fluid3D([8154,7312,7283,7644],0); -ELEMENTS[17696] = Fluid3D([7023,7704,7312,6741],0); -ELEMENTS[17697] = Fluid3D([7704,7827,8384,8542],0); -ELEMENTS[17698] = Fluid3D([8084,8154,7826,8740],0); -ELEMENTS[17699] = Fluid3D([8154,7826,8740,8927],0); -ELEMENTS[17700] = Fluid3D([8084,8154,8740,9044],0); -ELEMENTS[17701] = Fluid3D([8740,8084,9044,8792],0); -ELEMENTS[17702] = Fluid3D([8084,9044,8792,8446],0); -ELEMENTS[17703] = Fluid3D([8740,8084,8792,7826],0); -ELEMENTS[17704] = Fluid3D([7241,6406,6906,7253],0); -ELEMENTS[17705] = Fluid3D([7487,7241,8044,8502],0); -ELEMENTS[17706] = Fluid3D([7271,6906,6653,6443],0); -ELEMENTS[17707] = Fluid3D([6906,6653,6443,6150],0); -ELEMENTS[17708] = Fluid3D([7271,6906,6443,7253],0); -ELEMENTS[17709] = Fluid3D([6653,7271,6443,6690],0); -ELEMENTS[17710] = Fluid3D([7271,6443,6690,7244],0); -ELEMENTS[17711] = Fluid3D([6443,6653,6690,6013],0); -ELEMENTS[17712] = Fluid3D([6443,6653,6013,6150],0); -ELEMENTS[17713] = Fluid3D([6690,6443,6013,6116],0); -ELEMENTS[17714] = Fluid3D([6443,6013,6116,5479],0); -ELEMENTS[17715] = Fluid3D([6653,7271,6690,7471],0); -ELEMENTS[17716] = Fluid3D([6653,6690,6013,6645],0); -ELEMENTS[17717] = Fluid3D([6690,6443,6116,7244],0); -ELEMENTS[17718] = Fluid3D([6013,6690,6116,5757],0); -ELEMENTS[17719] = Fluid3D([7230,7367,6710,6757],0); -ELEMENTS[17720] = Fluid3D([7341,7304,6456,7117],0); -ELEMENTS[17721] = Fluid3D([6647,6406,6878,6068],0); -ELEMENTS[17722] = Fluid3D([7761,7980,8647,8193],0); -ELEMENTS[17723] = Fluid3D([8058,7532,7367,8245],0); -ELEMENTS[17724] = Fluid3D([5038,5417,5489,4905],0); -ELEMENTS[17725] = Fluid3D([10516,11514,10761,11002],0); -ELEMENTS[17726] = Fluid3D([7452,8122,7471,7294],0); -ELEMENTS[17727] = Fluid3D([8122,7471,7294,7821],0); -ELEMENTS[17728] = Fluid3D([7471,7294,7821,6924],0); -ELEMENTS[17729] = Fluid3D([7471,7452,7294,6653],0); -ELEMENTS[17730] = Fluid3D([7452,8122,7294,7584],0); -ELEMENTS[17731] = Fluid3D([8122,7471,7821,8389],0); -ELEMENTS[17732] = Fluid3D([7294,8122,7821,7558],0); -ELEMENTS[17733] = Fluid3D([7821,7294,7558,6924],0); -ELEMENTS[17734] = Fluid3D([15121,14804,15438,15100],0); -ELEMENTS[17735] = Fluid3D([6231,6538,6941,6668],0); -ELEMENTS[17736] = Fluid3D([7233,6780,7537,7330],0); -ELEMENTS[17737] = Fluid3D([5459,5152,4849,5261],0); -ELEMENTS[17738] = Fluid3D([7452,8271,8122,7584],0); -ELEMENTS[17739] = Fluid3D([16145,16211,15703,16229],0); -ELEMENTS[17740] = Fluid3D([12772,13394,13186,13709],0); -ELEMENTS[17741] = Fluid3D([13160,13313,13175,12465],0); -ELEMENTS[17742] = Fluid3D([13175,13160,12465,12537],0); -ELEMENTS[17743] = Fluid3D([13160,12465,12537,12268],0); -ELEMENTS[17744] = Fluid3D([13160,12465,12268,12730],0); -ELEMENTS[17745] = Fluid3D([12465,12268,12730,11778],0); -ELEMENTS[17746] = Fluid3D([12465,12537,12268,11522],0); -ELEMENTS[17747] = Fluid3D([12465,12537,11522,12383],0); -ELEMENTS[17748] = Fluid3D([13160,13313,12465,12730],0); -ELEMENTS[17749] = Fluid3D([12465,12537,12383,13175],0); -ELEMENTS[17750] = Fluid3D([12537,12268,11522,11850],0); -ELEMENTS[17751] = Fluid3D([12537,12268,11850,13149],0); -ELEMENTS[17752] = Fluid3D([11522,12537,11850,11463],0); -ELEMENTS[17753] = Fluid3D([12537,11850,11463,12480],0); -ELEMENTS[17754] = Fluid3D([11463,12537,12480,12686],0); -ELEMENTS[17755] = Fluid3D([11463,12537,12686,12383],0); -ELEMENTS[17756] = Fluid3D([12268,11522,11850,11284],0); -ELEMENTS[17757] = Fluid3D([11522,11850,11284,10909],0); -ELEMENTS[17758] = Fluid3D([11522,11850,10909,11463],0); -ELEMENTS[17759] = Fluid3D([12268,11522,11284,11778],0); -ELEMENTS[17760] = Fluid3D([12537,11850,12480,13149],0); -ELEMENTS[17761] = Fluid3D([11522,12537,11463,12383],0); -ELEMENTS[17762] = Fluid3D([11850,11284,10909,11060],0); -ELEMENTS[17763] = Fluid3D([11850,11284,11060,11952],0); -ELEMENTS[17764] = Fluid3D([11060,11850,11952,11929],0); -ELEMENTS[17765] = Fluid3D([11060,11850,11929,11359],0); -ELEMENTS[17766] = Fluid3D([11060,11850,11359,10909],0); -ELEMENTS[17767] = Fluid3D([11284,10909,11060,10274],0); -ELEMENTS[17768] = Fluid3D([10909,11060,10274,10207],0); -ELEMENTS[17769] = Fluid3D([11060,10274,10207,10131],0); -ELEMENTS[17770] = Fluid3D([10909,11060,10207,11359],0); -ELEMENTS[17771] = Fluid3D([11060,10274,10131,10778],0); -ELEMENTS[17772] = Fluid3D([10274,10131,10778,9756],0); -ELEMENTS[17773] = Fluid3D([10274,10131,9756,9286],0); -ELEMENTS[17774] = Fluid3D([9756,10274,9286,9400],0); -ELEMENTS[17775] = Fluid3D([9756,10274,9400,10322],0); -ELEMENTS[17776] = Fluid3D([9756,10274,10322,10778],0); -ELEMENTS[17777] = Fluid3D([11284,10909,10274,10593],0); -ELEMENTS[17778] = Fluid3D([10274,11284,10593,10322],0); -ELEMENTS[17779] = Fluid3D([11284,10909,10593,11522],0); -ELEMENTS[17780] = Fluid3D([11060,10274,10778,11284],0); -ELEMENTS[17781] = Fluid3D([10274,10131,9286,10207],0); -ELEMENTS[17782] = Fluid3D([11850,11284,11952,12268],0); -ELEMENTS[17783] = Fluid3D([9400,9756,10322,9409],0); -ELEMENTS[17784] = Fluid3D([9756,10322,9409,10202],0); -ELEMENTS[17785] = Fluid3D([10322,9409,10202,10205],0); -ELEMENTS[17786] = Fluid3D([9409,10202,10205,9587],0); -ELEMENTS[17787] = Fluid3D([9409,10202,9587,9129],0); -ELEMENTS[17788] = Fluid3D([9587,9409,9129,8909],0); -ELEMENTS[17789] = Fluid3D([9409,9129,8909,8459],0); -ELEMENTS[17790] = Fluid3D([9587,9409,8909,10205],0); -ELEMENTS[17791] = Fluid3D([8909,9409,8459,8498],0); -ELEMENTS[17792] = Fluid3D([9400,9756,9409,8459],0); -ELEMENTS[17793] = Fluid3D([9129,9587,8909,8284],0); -ELEMENTS[17794] = Fluid3D([9409,8909,10205,9378],0); -ELEMENTS[17795] = Fluid3D([9409,8909,9378,8498],0); -ELEMENTS[17796] = Fluid3D([10205,9409,9378,10322],0); -ELEMENTS[17797] = Fluid3D([10322,9400,9409,9378],0); -ELEMENTS[17798] = Fluid3D([9756,10322,10202,10778],0); -ELEMENTS[17799] = Fluid3D([9409,9756,10202,9129],0); -ELEMENTS[17800] = Fluid3D([9409,9756,9129,8459],0); -ELEMENTS[17801] = Fluid3D([11952,11060,11929,11409],0); -ELEMENTS[17802] = Fluid3D([11929,11952,11409,12415],0); -ELEMENTS[17803] = Fluid3D([11409,11929,12415,11970],0); -ELEMENTS[17804] = Fluid3D([12415,11409,11970,11981],0); -ELEMENTS[17805] = Fluid3D([12415,11409,11981,11894],0); -ELEMENTS[17806] = Fluid3D([12415,11409,11894,11952],0); -ELEMENTS[17807] = Fluid3D([11952,11060,11409,10778],0); -ELEMENTS[17808] = Fluid3D([11409,11929,11970,11103],0); -ELEMENTS[17809] = Fluid3D([11970,11409,11103,11064],0); -ELEMENTS[17810] = Fluid3D([11409,11929,11103,11060],0); -ELEMENTS[17811] = Fluid3D([11929,11970,11103,11934],0); -ELEMENTS[17812] = Fluid3D([11103,11929,11934,11359],0); -ELEMENTS[17813] = Fluid3D([11929,11970,11934,12739],0); -ELEMENTS[17814] = Fluid3D([11929,11970,12739,12415],0); -ELEMENTS[17815] = Fluid3D([11970,11934,12739,12650],0); -ELEMENTS[17816] = Fluid3D([11970,11934,12650,11524],0); -ELEMENTS[17817] = Fluid3D([11970,11934,11524,11103],0); -ELEMENTS[17818] = Fluid3D([12739,11970,12650,12896],0); -ELEMENTS[17819] = Fluid3D([11970,12650,12896,12127],0); -ELEMENTS[17820] = Fluid3D([11970,12650,12127,11524],0); -ELEMENTS[17821] = Fluid3D([12739,11970,12896,12415],0); -ELEMENTS[17822] = Fluid3D([11970,11409,11064,11981],0); -ELEMENTS[17823] = Fluid3D([11934,11929,12739,12459],0); -ELEMENTS[17824] = Fluid3D([11929,12739,12459,12794],0); -ELEMENTS[17825] = Fluid3D([12739,11934,12459,13297],0); -ELEMENTS[17826] = Fluid3D([11934,11929,12459,11359],0); -ELEMENTS[17827] = Fluid3D([11929,12739,12794,12415],0); -ELEMENTS[17828] = Fluid3D([12459,11929,12794,11850],0); -ELEMENTS[17829] = Fluid3D([12650,12739,12896,13711],0); -ELEMENTS[17830] = Fluid3D([11929,11952,12415,12794],0); -ELEMENTS[17831] = Fluid3D([11409,11103,11064,10131],0); -ELEMENTS[17832] = Fluid3D([11970,12415,11981,12896],0); -ELEMENTS[17833] = Fluid3D([10131,11060,10778,11409],0); -ELEMENTS[17834] = Fluid3D([11934,12739,12650,13297],0); -ELEMENTS[17835] = Fluid3D([11850,11952,11929,12794],0); -ELEMENTS[17836] = Fluid3D([12465,12268,11778,11522],0); -ELEMENTS[17837] = Fluid3D([9286,9756,9400,8910],0); -ELEMENTS[17838] = Fluid3D([10202,10205,9587,10592],0); -ELEMENTS[17839] = Fluid3D([9587,10202,10592,10035],0); -ELEMENTS[17840] = Fluid3D([10202,10592,10035,11000],0); -ELEMENTS[17841] = Fluid3D([10592,10035,11000,10901],0); -ELEMENTS[17842] = Fluid3D([10202,10205,10592,11104],0); -ELEMENTS[17843] = Fluid3D([11000,10592,10901,11603],0); -ELEMENTS[17844] = Fluid3D([11000,10592,11603,11104],0); -ELEMENTS[17845] = Fluid3D([10202,10205,11104,10322],0); -ELEMENTS[17846] = Fluid3D([10901,11000,11603,11729],0); -ELEMENTS[17847] = Fluid3D([11000,11603,11729,11996],0); -ELEMENTS[17848] = Fluid3D([10901,11000,11729,10830],0); -ELEMENTS[17849] = Fluid3D([11000,11603,11996,11104],0); -ELEMENTS[17850] = Fluid3D([10901,11000,10830,10035],0); -ELEMENTS[17851] = Fluid3D([11603,11729,11996,12511],0); -ELEMENTS[17852] = Fluid3D([11603,11729,12511,11921],0); -ELEMENTS[17853] = Fluid3D([11729,11996,12511,12541],0); -ELEMENTS[17854] = Fluid3D([11996,11603,12511,12333],0); -ELEMENTS[17855] = Fluid3D([11996,11603,12333,11104],0); -ELEMENTS[17856] = Fluid3D([11729,11996,12541,11671],0); -ELEMENTS[17857] = Fluid3D([11729,11996,11671,11000],0); -ELEMENTS[17858] = Fluid3D([11996,12541,11671,11894],0); -ELEMENTS[17859] = Fluid3D([11671,11996,11894,11000],0); -ELEMENTS[17860] = Fluid3D([11603,11729,11921,10901],0); -ELEMENTS[17861] = Fluid3D([10592,10035,10901,10023],0); -ELEMENTS[17862] = Fluid3D([10592,10035,10023,9587],0); -ELEMENTS[17863] = Fluid3D([10035,10901,10023,10054],0); -ELEMENTS[17864] = Fluid3D([10901,10023,10054,10605],0); -ELEMENTS[17865] = Fluid3D([10901,10592,10023,10965],0); -ELEMENTS[17866] = Fluid3D([10901,10592,10965,11603],0); -ELEMENTS[17867] = Fluid3D([10901,10023,10605,10965],0); -ELEMENTS[17868] = Fluid3D([10035,10901,10054,10830],0); -ELEMENTS[17869] = Fluid3D([10054,10901,10605,11030],0); -ELEMENTS[17870] = Fluid3D([10054,10901,11030,10830],0); -ELEMENTS[17871] = Fluid3D([10605,10054,11030,10231],0); -ELEMENTS[17872] = Fluid3D([10901,10605,11030,11921],0); -ELEMENTS[17873] = Fluid3D([10054,11030,10231,10271],0); -ELEMENTS[17874] = Fluid3D([10054,11030,10271,10830],0); -ELEMENTS[17875] = Fluid3D([11030,10231,10271,10975],0); -ELEMENTS[17876] = Fluid3D([10231,10271,10975,9871],0); -ELEMENTS[17877] = Fluid3D([11030,10231,10975,11158],0); -ELEMENTS[17878] = Fluid3D([11030,10231,11158,10605],0); -ELEMENTS[17879] = Fluid3D([10231,10975,11158,10823],0); -ELEMENTS[17880] = Fluid3D([10975,11158,10823,12095],0); -ELEMENTS[17881] = Fluid3D([10231,10975,10823,9871],0); -ELEMENTS[17882] = Fluid3D([10202,10592,11000,11104],0); -ELEMENTS[17883] = Fluid3D([10605,10054,10231,9610],0); -ELEMENTS[17884] = Fluid3D([10054,10231,9610,9127],0); -ELEMENTS[17885] = Fluid3D([10605,10054,9610,10023],0); -ELEMENTS[17886] = Fluid3D([10231,10605,9610,10030],0); -ELEMENTS[17887] = Fluid3D([9610,10231,10030,9127],0); -ELEMENTS[17888] = Fluid3D([10231,10030,9127,9871],0); -ELEMENTS[17889] = Fluid3D([10231,10030,9871,10823],0); -ELEMENTS[17890] = Fluid3D([10231,10030,10823,11158],0); -ELEMENTS[17891] = Fluid3D([10231,10030,11158,10605],0); -ELEMENTS[17892] = Fluid3D([10023,10035,10054,9215],0); -ELEMENTS[17893] = Fluid3D([10023,10035,9215,9587],0); -ELEMENTS[17894] = Fluid3D([10035,10054,9215,9527],0); -ELEMENTS[17895] = Fluid3D([10035,10054,9527,10830],0); -ELEMENTS[17896] = Fluid3D([10054,10023,9215,9610],0); -ELEMENTS[17897] = Fluid3D([10054,9215,9527,9171],0); -ELEMENTS[17898] = Fluid3D([9215,9527,9171,8426],0); -ELEMENTS[17899] = Fluid3D([10054,9215,9171,9610],0); -ELEMENTS[17900] = Fluid3D([9527,10054,9171,10271],0); -ELEMENTS[17901] = Fluid3D([9215,10035,9527,9129],0); -ELEMENTS[17902] = Fluid3D([10205,9587,10592,10042],0); -ELEMENTS[17903] = Fluid3D([9587,10592,10042,10023],0); -ELEMENTS[17904] = Fluid3D([10205,9587,10042,9311],0); -ELEMENTS[17905] = Fluid3D([10592,10205,10042,11009],0); -ELEMENTS[17906] = Fluid3D([10042,10592,11009,10965],0); -ELEMENTS[17907] = Fluid3D([10042,10205,9311,10133],0); -ELEMENTS[17908] = Fluid3D([10042,10205,10133,11009],0); -ELEMENTS[17909] = Fluid3D([10205,9311,10133,9378],0); -ELEMENTS[17910] = Fluid3D([10592,10205,11009,11104],0); -ELEMENTS[17911] = Fluid3D([10205,9587,9311,8909],0); -ELEMENTS[17912] = Fluid3D([9587,9311,8909,8322],0); -ELEMENTS[17913] = Fluid3D([9311,10042,10133,9462],0); -ELEMENTS[17914] = Fluid3D([10042,10133,9462,10473],0); -ELEMENTS[17915] = Fluid3D([9462,10042,10473,9854],0); -ELEMENTS[17916] = Fluid3D([10133,9311,9462,9238],0); -ELEMENTS[17917] = Fluid3D([9311,10042,9462,9096],0); -ELEMENTS[17918] = Fluid3D([10133,9311,9238,9378],0); -ELEMENTS[17919] = Fluid3D([9311,10042,9096,9587],0); -ELEMENTS[17920] = Fluid3D([9462,10042,9854,9096],0); -ELEMENTS[17921] = Fluid3D([10473,9462,9854,9817],0); -ELEMENTS[17922] = Fluid3D([9462,9854,9817,8996],0); -ELEMENTS[17923] = Fluid3D([9854,10473,9817,10640],0); -ELEMENTS[17924] = Fluid3D([9854,10473,10640,10859],0); -ELEMENTS[17925] = Fluid3D([9854,10473,10859,10042],0); -ELEMENTS[17926] = Fluid3D([10473,9462,9817,10098],0); -ELEMENTS[17927] = Fluid3D([9817,10473,10098,10743],0); -ELEMENTS[17928] = Fluid3D([10473,9462,10098,10133],0); -ELEMENTS[17929] = Fluid3D([9817,10473,10743,10640],0); -ELEMENTS[17930] = Fluid3D([9462,9854,8996,9096],0); -ELEMENTS[17931] = Fluid3D([9817,9462,8996,9009],0); -ELEMENTS[17932] = Fluid3D([8996,9817,9009,9070],0); -ELEMENTS[17933] = Fluid3D([9817,9462,9009,10098],0); -ELEMENTS[17934] = Fluid3D([9462,8996,9009,8497],0); -ELEMENTS[17935] = Fluid3D([8996,9009,8497,8187],0); -ELEMENTS[17936] = Fluid3D([8996,9009,8187,9070],0); -ELEMENTS[17937] = Fluid3D([9462,8996,8497,9096],0); -ELEMENTS[17938] = Fluid3D([9009,8497,8187,8166],0); -ELEMENTS[17939] = Fluid3D([8497,8187,8166,7612],0); -ELEMENTS[17940] = Fluid3D([9009,8497,8166,9238],0); -ELEMENTS[17941] = Fluid3D([8497,8187,7612,7955],0); -ELEMENTS[17942] = Fluid3D([8187,8166,7612,7333],0); -ELEMENTS[17943] = Fluid3D([8187,8166,7333,8333],0); -ELEMENTS[17944] = Fluid3D([8166,7612,7333,7213],0); -ELEMENTS[17945] = Fluid3D([8166,7612,7213,7566],0); -ELEMENTS[17946] = Fluid3D([7612,8187,7333,7339],0); -ELEMENTS[17947] = Fluid3D([8187,8166,8333,9009],0); -ELEMENTS[17948] = Fluid3D([10042,10133,10473,11009],0); -ELEMENTS[17949] = Fluid3D([8996,9817,9070,9593],0); -ELEMENTS[17950] = Fluid3D([8996,9817,9593,9854],0); -ELEMENTS[17951] = Fluid3D([9817,9070,9593,10012],0); -ELEMENTS[17952] = Fluid3D([9593,9817,10012,10640],0); -ELEMENTS[17953] = Fluid3D([9817,9070,10012,9680],0); -ELEMENTS[17954] = Fluid3D([9070,10012,9680,9354],0); -ELEMENTS[17955] = Fluid3D([9070,10012,9354,9047],0); -ELEMENTS[17956] = Fluid3D([9817,9070,9680,9009],0); -ELEMENTS[17957] = Fluid3D([9070,8996,9593,8817],0); -ELEMENTS[17958] = Fluid3D([9070,9593,10012,9047],0); -ELEMENTS[17959] = Fluid3D([10012,9680,9354,10327],0); -ELEMENTS[17960] = Fluid3D([10012,9680,10327,10743],0); -ELEMENTS[17961] = Fluid3D([9680,9354,10327,9570],0); -ELEMENTS[17962] = Fluid3D([9680,9354,9570,9015],0); -ELEMENTS[17963] = Fluid3D([9680,9354,9015,9070],0); -ELEMENTS[17964] = Fluid3D([10327,9680,9570,10373],0); -ELEMENTS[17965] = Fluid3D([9680,9570,10373,9463],0); -ELEMENTS[17966] = Fluid3D([9680,9570,9463,9015],0); -ELEMENTS[17967] = Fluid3D([10327,9680,10373,10743],0); -ELEMENTS[17968] = Fluid3D([9354,10012,10327,10102],0); -ELEMENTS[17969] = Fluid3D([9354,10012,10102,9047],0); -ELEMENTS[17970] = Fluid3D([10012,10327,10102,10956],0); -ELEMENTS[17971] = Fluid3D([10327,10102,10956,10933],0); -ELEMENTS[17972] = Fluid3D([10327,10102,10933,9950],0); -ELEMENTS[17973] = Fluid3D([10327,10102,9950,9354],0); -ELEMENTS[17974] = Fluid3D([10102,10012,10956,9983],0); -ELEMENTS[17975] = Fluid3D([10012,10327,10956,10743],0); -ELEMENTS[17976] = Fluid3D([9354,10327,9570,9950],0); -ELEMENTS[17977] = Fluid3D([9009,9462,8497,9238],0); -ELEMENTS[17978] = Fluid3D([10012,9817,9680,10743],0); -ELEMENTS[17979] = Fluid3D([9354,9570,9015,8803],0); -ELEMENTS[17980] = Fluid3D([9015,9354,8803,8416],0); -ELEMENTS[17981] = Fluid3D([9570,9015,8803,8612],0); -ELEMENTS[17982] = Fluid3D([9570,9015,8612,9463],0); -ELEMENTS[17983] = Fluid3D([8803,9570,8612,9287],0); -ELEMENTS[17984] = Fluid3D([9570,8612,9287,9618],0); -ELEMENTS[17985] = Fluid3D([8612,9287,9618,8877],0); -ELEMENTS[17986] = Fluid3D([8612,9287,8877,8347],0); -ELEMENTS[17987] = Fluid3D([8612,9287,8347,8803],0); -ELEMENTS[17988] = Fluid3D([9354,9570,8803,9950],0); -ELEMENTS[17989] = Fluid3D([9287,9618,8877,9798],0); -ELEMENTS[17990] = Fluid3D([9618,8877,9798,9564],0); -ELEMENTS[17991] = Fluid3D([9618,8877,9564,8884],0); -ELEMENTS[17992] = Fluid3D([9618,8877,8884,8612],0); -ELEMENTS[17993] = Fluid3D([9287,9618,9798,10281],0); -ELEMENTS[17994] = Fluid3D([9287,9618,10281,9570],0); -ELEMENTS[17995] = Fluid3D([9798,9287,10281,9969],0); -ELEMENTS[17996] = Fluid3D([10281,9798,9969,10555],0); -ELEMENTS[17997] = Fluid3D([9798,9287,9969,9108],0); -ELEMENTS[17998] = Fluid3D([10281,9798,10555,10621],0); -ELEMENTS[17999] = Fluid3D([10281,9798,10621,9618],0); -ELEMENTS[18000] = Fluid3D([9798,9287,9108,8877],0); -ELEMENTS[18001] = Fluid3D([8877,9798,9564,9207],0); -ELEMENTS[18002] = Fluid3D([9564,8877,9207,8649],0); -ELEMENTS[18003] = Fluid3D([8877,9798,9207,9108],0); -ELEMENTS[18004] = Fluid3D([9798,9564,9207,10210],0); -ELEMENTS[18005] = Fluid3D([9798,9564,10210,10621],0); -ELEMENTS[18006] = Fluid3D([9564,9207,10210,9517],0); -ELEMENTS[18007] = Fluid3D([9564,9207,9517,8649],0); -ELEMENTS[18008] = Fluid3D([9207,10210,9517,9714],0); -ELEMENTS[18009] = Fluid3D([9207,10210,9714,9853],0); -ELEMENTS[18010] = Fluid3D([9207,10210,9853,9798],0); -ELEMENTS[18011] = Fluid3D([10210,9517,9714,10361],0); -ELEMENTS[18012] = Fluid3D([9564,8877,8649,8884],0); -ELEMENTS[18013] = Fluid3D([9570,8612,9618,9463],0); -ELEMENTS[18014] = Fluid3D([8803,9570,9287,9950],0); -ELEMENTS[18015] = Fluid3D([9287,10281,9969,9950],0); -ELEMENTS[18016] = Fluid3D([9015,8803,8612,8097],0); -ELEMENTS[18017] = Fluid3D([8612,9015,8097,8333],0); -ELEMENTS[18018] = Fluid3D([9015,8097,8333,8416],0); -ELEMENTS[18019] = Fluid3D([8612,9015,8333,9463],0); -ELEMENTS[18020] = Fluid3D([8803,8612,8097,8347],0); -ELEMENTS[18021] = Fluid3D([9015,8803,8097,8416],0); -ELEMENTS[18022] = Fluid3D([9517,9207,9714,8799],0); -ELEMENTS[18023] = Fluid3D([9714,9517,8799,9374],0); -ELEMENTS[18024] = Fluid3D([9207,9714,8799,8978],0); -ELEMENTS[18025] = Fluid3D([9714,8799,8978,9110],0); -ELEMENTS[18026] = Fluid3D([9517,9207,8799,8649],0); -ELEMENTS[18027] = Fluid3D([8799,8978,9110,8210],0); -ELEMENTS[18028] = Fluid3D([8799,8978,8210,8209],0); -ELEMENTS[18029] = Fluid3D([8799,8978,8209,9207],0); -ELEMENTS[18030] = Fluid3D([8978,9110,8210,8746],0); -ELEMENTS[18031] = Fluid3D([8978,9110,8746,9677],0); -ELEMENTS[18032] = Fluid3D([8978,9110,9677,9714],0); -ELEMENTS[18033] = Fluid3D([8210,8978,8746,8182],0); -ELEMENTS[18034] = Fluid3D([8978,8746,8182,9054],0); -ELEMENTS[18035] = Fluid3D([8210,8978,8182,8209],0); -ELEMENTS[18036] = Fluid3D([8978,8746,9054,9677],0); -ELEMENTS[18037] = Fluid3D([9714,8799,9110,9374],0); -ELEMENTS[18038] = Fluid3D([9207,9714,8978,9853],0); -ELEMENTS[18039] = Fluid3D([8746,8210,8182,7805],0); -ELEMENTS[18040] = Fluid3D([8746,8210,7805,8345],0); -ELEMENTS[18041] = Fluid3D([8210,7805,8345,7541],0); -ELEMENTS[18042] = Fluid3D([8210,7805,7541,7403],0); -ELEMENTS[18043] = Fluid3D([8210,7805,7403,8182],0); -ELEMENTS[18044] = Fluid3D([8182,8746,7805,8276],0); -ELEMENTS[18045] = Fluid3D([8746,7805,8276,8375],0); -ELEMENTS[18046] = Fluid3D([8182,8746,8276,9054],0); -ELEMENTS[18047] = Fluid3D([8746,7805,8375,8345],0); -ELEMENTS[18048] = Fluid3D([8746,8210,8345,9110],0); -ELEMENTS[18049] = Fluid3D([7805,8182,8276,7309],0); -ELEMENTS[18050] = Fluid3D([7805,8345,7541,7580],0); -ELEMENTS[18051] = Fluid3D([8345,7541,7580,7790],0); -ELEMENTS[18052] = Fluid3D([7541,7805,7580,6966],0); -ELEMENTS[18053] = Fluid3D([7541,7580,7790,6955],0); -ELEMENTS[18054] = Fluid3D([7541,7580,6955,6966],0); -ELEMENTS[18055] = Fluid3D([7805,8345,7580,8375],0); -ELEMENTS[18056] = Fluid3D([7541,7805,6966,7403],0); -ELEMENTS[18057] = Fluid3D([8345,7541,7790,8306],0); -ELEMENTS[18058] = Fluid3D([8345,7541,8306,8210],0); -ELEMENTS[18059] = Fluid3D([7541,7790,8306,7401],0); -ELEMENTS[18060] = Fluid3D([7790,8306,7401,8686],0); -ELEMENTS[18061] = Fluid3D([7790,8345,8306,8686],0); -ELEMENTS[18062] = Fluid3D([8306,7541,7401,7621],0); -ELEMENTS[18063] = Fluid3D([7401,8306,7621,7941],0); -ELEMENTS[18064] = Fluid3D([8306,7541,7621,8210],0); -ELEMENTS[18065] = Fluid3D([7541,7401,7621,6821],0); -ELEMENTS[18066] = Fluid3D([7401,8306,7941,8066],0); -ELEMENTS[18067] = Fluid3D([7401,8306,8066,8686],0); -ELEMENTS[18068] = Fluid3D([8306,7941,8066,8815],0); -ELEMENTS[18069] = Fluid3D([8306,7941,8815,8550],0); -ELEMENTS[18070] = Fluid3D([8306,7941,8550,7621],0); -ELEMENTS[18071] = Fluid3D([7941,7401,8066,7681],0); -ELEMENTS[18072] = Fluid3D([8066,7941,7681,8815],0); -ELEMENTS[18073] = Fluid3D([7941,7401,7681,7034],0); -ELEMENTS[18074] = Fluid3D([7681,7941,7034,7589],0); -ELEMENTS[18075] = Fluid3D([7681,7941,7589,8380],0); -ELEMENTS[18076] = Fluid3D([7681,7941,8380,8815],0); -ELEMENTS[18077] = Fluid3D([7941,7589,8380,8353],0); -ELEMENTS[18078] = Fluid3D([8380,7941,8353,8815],0); -ELEMENTS[18079] = Fluid3D([7941,7589,8353,7189],0); -ELEMENTS[18080] = Fluid3D([7941,7401,7034,7621],0); -ELEMENTS[18081] = Fluid3D([7589,7681,8380,7707],0); -ELEMENTS[18082] = Fluid3D([7681,8380,7707,8226],0); -ELEMENTS[18083] = Fluid3D([7681,8380,8226,8815],0); -ELEMENTS[18084] = Fluid3D([8380,7707,8226,8584],0); -ELEMENTS[18085] = Fluid3D([7941,7034,7589,7189],0); -ELEMENTS[18086] = Fluid3D([8380,7707,8584,8202],0); -ELEMENTS[18087] = Fluid3D([8380,7707,8202,7589],0); -ELEMENTS[18088] = Fluid3D([8226,8380,8584,9126],0); -ELEMENTS[18089] = Fluid3D([8226,8380,9126,8815],0); -ELEMENTS[18090] = Fluid3D([7401,7034,7621,6821],0); -ELEMENTS[18091] = Fluid3D([8584,8380,8202,9109],0); -ELEMENTS[18092] = Fluid3D([8584,8380,9109,9126],0); -ELEMENTS[18093] = Fluid3D([8380,8202,9109,8353],0); -ELEMENTS[18094] = Fluid3D([7707,7681,8226,7354],0); -ELEMENTS[18095] = Fluid3D([7681,8226,7354,7784],0); -ELEMENTS[18096] = Fluid3D([7681,8226,7784,8066],0); -ELEMENTS[18097] = Fluid3D([8226,7354,7784,8471],0); -ELEMENTS[18098] = Fluid3D([7707,8584,8202,7967],0); -ELEMENTS[18099] = Fluid3D([8202,7707,7967,7147],0); -ELEMENTS[18100] = Fluid3D([7707,8584,7967,7928],0); -ELEMENTS[18101] = Fluid3D([7354,7681,7784,6997],0); -ELEMENTS[18102] = Fluid3D([7681,7784,6997,8066],0); -ELEMENTS[18103] = Fluid3D([7354,7681,6997,6947],0); -ELEMENTS[18104] = Fluid3D([8584,8226,9126,9506],0); -ELEMENTS[18105] = Fluid3D([7707,8226,8584,7928],0); -ELEMENTS[18106] = Fluid3D([8202,8584,9109,8822],0); -ELEMENTS[18107] = Fluid3D([7589,8380,8353,8202],0); -ELEMENTS[18108] = Fluid3D([7707,7681,7354,6947],0); -ELEMENTS[18109] = Fluid3D([7541,7790,7401,6955],0); -ELEMENTS[18110] = Fluid3D([7805,7580,6966,7381],0); -ELEMENTS[18111] = Fluid3D([7580,6966,7381,6796],0); -ELEMENTS[18112] = Fluid3D([6966,7381,6796,6825],0); -ELEMENTS[18113] = Fluid3D([6966,7381,6825,7309],0); -ELEMENTS[18114] = Fluid3D([7381,6796,6825,7155],0); -ELEMENTS[18115] = Fluid3D([6825,7381,7155,7659],0); -ELEMENTS[18116] = Fluid3D([6825,7381,7659,7309],0); -ELEMENTS[18117] = Fluid3D([7805,7580,7381,8375],0); -ELEMENTS[18118] = Fluid3D([7381,7155,7659,8033],0); -ELEMENTS[18119] = Fluid3D([7659,7381,8033,8276],0); -ELEMENTS[18120] = Fluid3D([7381,7580,6796,7557],0); -ELEMENTS[18121] = Fluid3D([6796,7381,7557,7155],0); -ELEMENTS[18122] = Fluid3D([7381,7580,7557,8375],0); -ELEMENTS[18123] = Fluid3D([7580,6796,7557,7243],0); -ELEMENTS[18124] = Fluid3D([6796,7557,7243,6835],0); -ELEMENTS[18125] = Fluid3D([7580,6796,7243,6955],0); -ELEMENTS[18126] = Fluid3D([6796,7557,6835,7155],0); -ELEMENTS[18127] = Fluid3D([7580,6966,6796,6955],0); -ELEMENTS[18128] = Fluid3D([7557,7580,7243,8121],0); -ELEMENTS[18129] = Fluid3D([7243,7557,8121,7699],0); -ELEMENTS[18130] = Fluid3D([7580,7243,8121,7790],0); -ELEMENTS[18131] = Fluid3D([7557,7580,8121,8375],0); -ELEMENTS[18132] = Fluid3D([7557,8121,7699,8359],0); -ELEMENTS[18133] = Fluid3D([7699,7557,8359,7581],0); -ELEMENTS[18134] = Fluid3D([7557,8121,8359,8375],0); -ELEMENTS[18135] = Fluid3D([8121,7699,8359,8574],0); -ELEMENTS[18136] = Fluid3D([8121,7699,8574,7917],0); -ELEMENTS[18137] = Fluid3D([7699,8359,8574,8302],0); -ELEMENTS[18138] = Fluid3D([8121,7699,7917,7243],0); -ELEMENTS[18139] = Fluid3D([7699,8359,8302,7581],0); -ELEMENTS[18140] = Fluid3D([7243,7557,7699,6835],0); -ELEMENTS[18141] = Fluid3D([7699,7557,7581,6835],0); -ELEMENTS[18142] = Fluid3D([6966,7805,7381,7309],0); -ELEMENTS[18143] = Fluid3D([9110,8746,9677,9396],0); -ELEMENTS[18144] = Fluid3D([9110,8746,9396,8345],0); -ELEMENTS[18145] = Fluid3D([8746,9677,9396,9428],0); -ELEMENTS[18146] = Fluid3D([9396,8746,9428,8375],0); -ELEMENTS[18147] = Fluid3D([8746,9677,9428,9054],0); -ELEMENTS[18148] = Fluid3D([9677,9110,9396,10104],0); -ELEMENTS[18149] = Fluid3D([9677,9396,9428,10290],0); -ELEMENTS[18150] = Fluid3D([9677,9396,10290,10104],0); -ELEMENTS[18151] = Fluid3D([9396,9428,10290,9744],0); -ELEMENTS[18152] = Fluid3D([9396,9428,9744,8375],0); -ELEMENTS[18153] = Fluid3D([10290,9396,9744,10708],0); -ELEMENTS[18154] = Fluid3D([9428,10290,9744,10243],0); -ELEMENTS[18155] = Fluid3D([9744,9428,10243,9334],0); -ELEMENTS[18156] = Fluid3D([10290,9744,10243,10781],0); -ELEMENTS[18157] = Fluid3D([9428,10290,10243,10252],0); -ELEMENTS[18158] = Fluid3D([10290,10243,10252,11324],0); -ELEMENTS[18159] = Fluid3D([9428,10290,10252,9677],0); -ELEMENTS[18160] = Fluid3D([10243,9744,9334,10113],0); -ELEMENTS[18161] = Fluid3D([9334,10243,10113,10072],0); -ELEMENTS[18162] = Fluid3D([9744,9334,10113,9212],0); -ELEMENTS[18163] = Fluid3D([9744,9334,9212,8375],0); -ELEMENTS[18164] = Fluid3D([10243,9744,10113,10781],0); -ELEMENTS[18165] = Fluid3D([9744,9428,9334,8375],0); -ELEMENTS[18166] = Fluid3D([9334,10243,10072,9668],0); -ELEMENTS[18167] = Fluid3D([9334,10243,9668,9428],0); -ELEMENTS[18168] = Fluid3D([10243,10072,9668,10688],0); -ELEMENTS[18169] = Fluid3D([10072,9668,10688,9441],0); -ELEMENTS[18170] = Fluid3D([10072,9668,9441,9334],0); -ELEMENTS[18171] = Fluid3D([9668,10243,10688,10252],0); -ELEMENTS[18172] = Fluid3D([10243,10072,10688,11186],0); -ELEMENTS[18173] = Fluid3D([10243,10113,10072,11186],0); -ELEMENTS[18174] = Fluid3D([9334,10113,9212,9382],0); -ELEMENTS[18175] = Fluid3D([9334,10113,9382,10072],0); -ELEMENTS[18176] = Fluid3D([9212,9334,9382,8530],0); -ELEMENTS[18177] = Fluid3D([9382,9212,8530,8771],0); -ELEMENTS[18178] = Fluid3D([9212,9334,8530,8375],0); -ELEMENTS[18179] = Fluid3D([10113,9212,9382,9754],0); -ELEMENTS[18180] = Fluid3D([9212,9382,9754,8771],0); -ELEMENTS[18181] = Fluid3D([10113,9212,9754,10051],0); -ELEMENTS[18182] = Fluid3D([9212,9754,10051,9216],0); -ELEMENTS[18183] = Fluid3D([9212,9754,9216,8771],0); -ELEMENTS[18184] = Fluid3D([10113,9212,10051,9744],0); -ELEMENTS[18185] = Fluid3D([9334,9382,8530,8923],0); -ELEMENTS[18186] = Fluid3D([9382,8530,8923,8418],0); -ELEMENTS[18187] = Fluid3D([8530,9382,8771,8418],0); -ELEMENTS[18188] = Fluid3D([9754,10113,10051,11382],0); -ELEMENTS[18189] = Fluid3D([9212,8530,8771,8359],0); -ELEMENTS[18190] = Fluid3D([9382,10113,9754,10475],0); -ELEMENTS[18191] = Fluid3D([10113,9754,10475,11382],0); -ELEMENTS[18192] = Fluid3D([7580,8345,7790,8121],0); -ELEMENTS[18193] = Fluid3D([9587,10202,10035,9129],0); -ELEMENTS[18194] = Fluid3D([9969,10281,10555,10902],0); -ELEMENTS[18195] = Fluid3D([9969,10281,10902,9950],0); -ELEMENTS[18196] = Fluid3D([10281,10555,10902,11328],0); -ELEMENTS[18197] = Fluid3D([10555,9969,10902,10811],0); -ELEMENTS[18198] = Fluid3D([9969,10902,10811,10364],0); -ELEMENTS[18199] = Fluid3D([10902,10811,10364,11401],0); -ELEMENTS[18200] = Fluid3D([10555,10902,11328,11692],0); -ELEMENTS[18201] = Fluid3D([10555,10902,11692,10811],0); -ELEMENTS[18202] = Fluid3D([10902,10811,11401,11692],0); -ELEMENTS[18203] = Fluid3D([9969,10902,10364,9950],0); -ELEMENTS[18204] = Fluid3D([10555,9969,10811,9853],0); -ELEMENTS[18205] = Fluid3D([10811,10364,11401,10841],0); -ELEMENTS[18206] = Fluid3D([10811,10364,10841,9925],0); -ELEMENTS[18207] = Fluid3D([10364,10841,9925,10244],0); -ELEMENTS[18208] = Fluid3D([10841,9925,10244,10478],0); -ELEMENTS[18209] = Fluid3D([10244,10841,10478,11268],0); -ELEMENTS[18210] = Fluid3D([10841,9925,10478,10811],0); -ELEMENTS[18211] = Fluid3D([10364,11401,10841,10914],0); -ELEMENTS[18212] = Fluid3D([10811,10364,9925,9969],0); -ELEMENTS[18213] = Fluid3D([11401,10811,10841,11702],0); -ELEMENTS[18214] = Fluid3D([10811,10841,11702,10478],0); -ELEMENTS[18215] = Fluid3D([11401,10811,11702,11692],0); -ELEMENTS[18216] = Fluid3D([10841,11401,11702,11968],0); -ELEMENTS[18217] = Fluid3D([11401,11702,11968,12845],0); -ELEMENTS[18218] = Fluid3D([10841,11401,11968,10914],0); -ELEMENTS[18219] = Fluid3D([11702,10841,11968,11533],0); -ELEMENTS[18220] = Fluid3D([10841,11968,11533,11268],0); -ELEMENTS[18221] = Fluid3D([11702,10841,11533,10478],0); -ELEMENTS[18222] = Fluid3D([10841,11533,10478,11268],0); -ELEMENTS[18223] = Fluid3D([11968,11702,11533,12403],0); -ELEMENTS[18224] = Fluid3D([11968,11702,12403,12845],0); -ELEMENTS[18225] = Fluid3D([11702,11533,12403,11906],0); -ELEMENTS[18226] = Fluid3D([12403,11702,11906,12619],0); -ELEMENTS[18227] = Fluid3D([11702,11533,11906,11018],0); -ELEMENTS[18228] = Fluid3D([11533,11906,11018,11237],0); -ELEMENTS[18229] = Fluid3D([11533,11906,11237,12193],0); -ELEMENTS[18230] = Fluid3D([11702,11533,11018,10478],0); -ELEMENTS[18231] = Fluid3D([11533,11018,10478,11237],0); -ELEMENTS[18232] = Fluid3D([11018,10478,11237,10320],0); -ELEMENTS[18233] = Fluid3D([11018,10478,10320,10009],0); -ELEMENTS[18234] = Fluid3D([11018,10478,10009,10811],0); -ELEMENTS[18235] = Fluid3D([10320,11018,10009,10624],0); -ELEMENTS[18236] = Fluid3D([11018,10009,10624,10811],0); -ELEMENTS[18237] = Fluid3D([10320,11018,10624,11500],0); -ELEMENTS[18238] = Fluid3D([10320,11018,11500,11237],0); -ELEMENTS[18239] = Fluid3D([11018,11500,11237,11906],0); -ELEMENTS[18240] = Fluid3D([11500,11237,11906,12064],0); -ELEMENTS[18241] = Fluid3D([11500,11237,12064,10688],0); -ELEMENTS[18242] = Fluid3D([11906,11500,12064,12560],0); -ELEMENTS[18243] = Fluid3D([10478,10320,10009,9641],0); -ELEMENTS[18244] = Fluid3D([11018,11500,11906,11525],0); -ELEMENTS[18245] = Fluid3D([11500,11906,11525,12560],0); -ELEMENTS[18246] = Fluid3D([11500,10320,11237,10688],0); -ELEMENTS[18247] = Fluid3D([11018,10624,11500,11525],0); -ELEMENTS[18248] = Fluid3D([11018,10624,11525,10811],0); -ELEMENTS[18249] = Fluid3D([10624,11500,11525,11324],0); -ELEMENTS[18250] = Fluid3D([10624,10320,11500,10252],0); -ELEMENTS[18251] = Fluid3D([10624,10320,10252,10009],0); -ELEMENTS[18252] = Fluid3D([10320,11500,10252,10688],0); -ELEMENTS[18253] = Fluid3D([11500,10624,10252,11324],0); -ELEMENTS[18254] = Fluid3D([10320,10252,10009,9401],0); -ELEMENTS[18255] = Fluid3D([10320,10252,9401,9668],0); -ELEMENTS[18256] = Fluid3D([10320,10252,9668,10688],0); -ELEMENTS[18257] = Fluid3D([9401,10320,9668,9065],0); -ELEMENTS[18258] = Fluid3D([9668,9401,9065,8763],0); -ELEMENTS[18259] = Fluid3D([9668,9401,8763,9428],0); -ELEMENTS[18260] = Fluid3D([9401,9065,8763,8158],0); -ELEMENTS[18261] = Fluid3D([9065,8763,8158,8514],0); -ELEMENTS[18262] = Fluid3D([8763,8158,8514,7659],0); -ELEMENTS[18263] = Fluid3D([9065,8763,8514,9668],0); -ELEMENTS[18264] = Fluid3D([11237,11906,12064,12193],0); -ELEMENTS[18265] = Fluid3D([11906,11018,11525,11702],0); -ELEMENTS[18266] = Fluid3D([11906,11525,12560,12619],0); -ELEMENTS[18267] = Fluid3D([12064,11906,12560,12657],0); -ELEMENTS[18268] = Fluid3D([11906,12560,12657,12403],0); -ELEMENTS[18269] = Fluid3D([12657,11906,12403,11533],0); -ELEMENTS[18270] = Fluid3D([12064,11906,12657,12193],0); -ELEMENTS[18271] = Fluid3D([12657,12064,12193,13217],0); -ELEMENTS[18272] = Fluid3D([12193,12657,13217,13028],0); -ELEMENTS[18273] = Fluid3D([12193,12657,13028,12250],0); -ELEMENTS[18274] = Fluid3D([12193,12657,12250,11533],0); -ELEMENTS[18275] = Fluid3D([12657,13028,12250,12403],0); -ELEMENTS[18276] = Fluid3D([12250,12657,12403,11533],0); -ELEMENTS[18277] = Fluid3D([12403,12250,11533,11968],0); -ELEMENTS[18278] = Fluid3D([12403,12250,11968,12747],0); -ELEMENTS[18279] = Fluid3D([12403,12250,12747,13028],0); -ELEMENTS[18280] = Fluid3D([12250,11533,11968,11268],0); -ELEMENTS[18281] = Fluid3D([11968,12403,12747,12845],0); -ELEMENTS[18282] = Fluid3D([13028,12193,12250,11634],0); -ELEMENTS[18283] = Fluid3D([10009,10320,9401,9641],0); -ELEMENTS[18284] = Fluid3D([10902,10281,11328,10930],0); -ELEMENTS[18285] = Fluid3D([11328,10902,10930,11791],0); -ELEMENTS[18286] = Fluid3D([10930,11328,11791,11802],0); -ELEMENTS[18287] = Fluid3D([10930,11328,11802,10916],0); -ELEMENTS[18288] = Fluid3D([10930,11328,10916,10281],0); -ELEMENTS[18289] = Fluid3D([10902,10281,10930,9950],0); -ELEMENTS[18290] = Fluid3D([11328,10902,11791,11692],0); -ELEMENTS[18291] = Fluid3D([11791,10930,11802,11595],0); -ELEMENTS[18292] = Fluid3D([11791,10930,11595,10933],0); -ELEMENTS[18293] = Fluid3D([10930,11595,10933,10956],0); -ELEMENTS[18294] = Fluid3D([11595,10933,10956,11706],0); -ELEMENTS[18295] = Fluid3D([11595,10933,11706,11723],0); -ELEMENTS[18296] = Fluid3D([11595,10933,11723,11791],0); -ELEMENTS[18297] = Fluid3D([10933,11706,11723,10881],0); -ELEMENTS[18298] = Fluid3D([10933,11706,10881,10102],0); -ELEMENTS[18299] = Fluid3D([11723,10933,10881,10824],0); -ELEMENTS[18300] = Fluid3D([11723,10933,10824,11791],0); -ELEMENTS[18301] = Fluid3D([11723,11595,11791,12345],0); -ELEMENTS[18302] = Fluid3D([11723,11595,12345,11706],0); -ELEMENTS[18303] = Fluid3D([10933,10881,10824,9950],0); -ELEMENTS[18304] = Fluid3D([11791,11723,12345,12308],0); -ELEMENTS[18305] = Fluid3D([11791,11723,12308,11401],0); -ELEMENTS[18306] = Fluid3D([11723,12345,12308,12542],0); -ELEMENTS[18307] = Fluid3D([11723,12345,12542,12259],0); -ELEMENTS[18308] = Fluid3D([11723,12345,12259,11706],0); -ELEMENTS[18309] = Fluid3D([12259,11723,11706,11859],0); -ELEMENTS[18310] = Fluid3D([11706,12259,11859,11930],0); -ELEMENTS[18311] = Fluid3D([12259,11723,11859,12542],0); -ELEMENTS[18312] = Fluid3D([11723,11706,11859,10881],0); -ELEMENTS[18313] = Fluid3D([11706,11859,10881,10958],0); -ELEMENTS[18314] = Fluid3D([11859,12259,12542,12695],0); -ELEMENTS[18315] = Fluid3D([11859,12259,12695,11930],0); -ELEMENTS[18316] = Fluid3D([10933,10956,11706,10102],0); -ELEMENTS[18317] = Fluid3D([12345,11791,12308,12987],0); -ELEMENTS[18318] = Fluid3D([12259,12542,12695,13148],0); -ELEMENTS[18319] = Fluid3D([12695,12259,13148,12841],0); -ELEMENTS[18320] = Fluid3D([12695,12259,12841,11930],0); -ELEMENTS[18321] = Fluid3D([12259,13148,12841,12676],0); -ELEMENTS[18322] = Fluid3D([12259,13148,12676,12345],0); -ELEMENTS[18323] = Fluid3D([13148,12695,12841,13289],0); -ELEMENTS[18324] = Fluid3D([12695,12841,13289,12599],0); -ELEMENTS[18325] = Fluid3D([13148,12695,13289,13559],0); -ELEMENTS[18326] = Fluid3D([12841,13148,13289,13562],0); -ELEMENTS[18327] = Fluid3D([12841,13148,13562,12676],0); -ELEMENTS[18328] = Fluid3D([13289,12841,13562,13042],0); -ELEMENTS[18329] = Fluid3D([12841,13562,13042,13312],0); -ELEMENTS[18330] = Fluid3D([13289,12841,13042,12599],0); -ELEMENTS[18331] = Fluid3D([13562,12841,12676,13312],0); -ELEMENTS[18332] = Fluid3D([12695,13289,13559,12863],0); -ELEMENTS[18333] = Fluid3D([12695,13289,12863,12599],0); -ELEMENTS[18334] = Fluid3D([13042,12841,13312,12368],0); -ELEMENTS[18335] = Fluid3D([13042,12841,12368,12599],0); -ELEMENTS[18336] = Fluid3D([10881,11723,10824,11508],0); -ELEMENTS[18337] = Fluid3D([11723,10824,11508,11401],0); -ELEMENTS[18338] = Fluid3D([10881,11723,11508,11859],0); -ELEMENTS[18339] = Fluid3D([10824,10881,11508,10573],0); -ELEMENTS[18340] = Fluid3D([10881,11508,10573,11253],0); -ELEMENTS[18341] = Fluid3D([10573,10881,11253,10250],0); -ELEMENTS[18342] = Fluid3D([10573,10881,10250,9950],0); -ELEMENTS[18343] = Fluid3D([10881,11253,10250,10958],0); -ELEMENTS[18344] = Fluid3D([10824,10881,10573,9950],0); -ELEMENTS[18345] = Fluid3D([11508,10824,10573,10914],0); -ELEMENTS[18346] = Fluid3D([10573,11508,10914,11568],0); -ELEMENTS[18347] = Fluid3D([10573,11508,11568,11253],0); -ELEMENTS[18348] = Fluid3D([11508,10914,11568,11883],0); -ELEMENTS[18349] = Fluid3D([10881,11508,11253,11859],0); -ELEMENTS[18350] = Fluid3D([11253,10881,11859,10958],0); -ELEMENTS[18351] = Fluid3D([11508,11253,11859,11568],0); -ELEMENTS[18352] = Fluid3D([11253,11859,11568,12219],0); -ELEMENTS[18353] = Fluid3D([11253,11859,12219,11930],0); -ELEMENTS[18354] = Fluid3D([11253,11859,11930,10958],0); -ELEMENTS[18355] = Fluid3D([11859,11508,11568,12542],0); -ELEMENTS[18356] = Fluid3D([11859,12219,11930,12695],0); -ELEMENTS[18357] = Fluid3D([11859,12219,12695,12542],0); -ELEMENTS[18358] = Fluid3D([12308,11723,12542,11508],0); -ELEMENTS[18359] = Fluid3D([12841,12259,12676,12069],0); -ELEMENTS[18360] = Fluid3D([12841,12259,12069,11930],0); -ELEMENTS[18361] = Fluid3D([12259,12676,12069,11864],0); -ELEMENTS[18362] = Fluid3D([12259,12676,11864,12345],0); -ELEMENTS[18363] = Fluid3D([12069,12259,11864,11706],0); -ELEMENTS[18364] = Fluid3D([12259,11864,11706,11595],0); -ELEMENTS[18365] = Fluid3D([11864,11706,11595,10956],0); -ELEMENTS[18366] = Fluid3D([12259,11864,11595,12345],0); -ELEMENTS[18367] = Fluid3D([11595,11864,10956,11330],0); -ELEMENTS[18368] = Fluid3D([11595,11864,11330,11802],0); -ELEMENTS[18369] = Fluid3D([11864,11595,12345,11802],0); -ELEMENTS[18370] = Fluid3D([12069,12259,11706,11930],0); -ELEMENTS[18371] = Fluid3D([11330,11595,11802,10930],0); -ELEMENTS[18372] = Fluid3D([11706,12259,11595,12345],0); -ELEMENTS[18373] = Fluid3D([11864,11330,11802,12304],0); -ELEMENTS[18374] = Fluid3D([11330,11802,12304,11715],0); -ELEMENTS[18375] = Fluid3D([11330,11802,11715,10916],0); -ELEMENTS[18376] = Fluid3D([11864,11330,12304,11745],0); -ELEMENTS[18377] = Fluid3D([11864,11330,11745,10956],0); -ELEMENTS[18378] = Fluid3D([12304,11330,11715,11672],0); -ELEMENTS[18379] = Fluid3D([11330,12304,11745,11672],0); -ELEMENTS[18380] = Fluid3D([11745,11330,11672,10743],0); -ELEMENTS[18381] = Fluid3D([12304,11745,11672,12404],0); -ELEMENTS[18382] = Fluid3D([11745,11672,12404,11705],0); -ELEMENTS[18383] = Fluid3D([11745,11672,11705,10743],0); -ELEMENTS[18384] = Fluid3D([11802,11330,10930,10916],0); -ELEMENTS[18385] = Fluid3D([11672,12404,11705,12119],0); -ELEMENTS[18386] = Fluid3D([11330,11715,11672,10743],0); -ELEMENTS[18387] = Fluid3D([12404,11745,11705,12206],0); -ELEMENTS[18388] = Fluid3D([11705,11672,12119,11204],0); -ELEMENTS[18389] = Fluid3D([11705,11672,11204,10743],0); -ELEMENTS[18390] = Fluid3D([11672,11204,10743,11088],0); -ELEMENTS[18391] = Fluid3D([11204,10743,11088,10098],0); -ELEMENTS[18392] = Fluid3D([10743,11672,11088,11715],0); -ELEMENTS[18393] = Fluid3D([11745,11705,12206,11299],0); -ELEMENTS[18394] = Fluid3D([11672,12404,12119,12373],0); -ELEMENTS[18395] = Fluid3D([11745,11705,11299,10743],0); -ELEMENTS[18396] = Fluid3D([11204,10743,10098,10473],0); -ELEMENTS[18397] = Fluid3D([11204,10743,10473,10640],0); -ELEMENTS[18398] = Fluid3D([10098,11204,10473,10133],0); -ELEMENTS[18399] = Fluid3D([11672,12404,12373,12304],0); -ELEMENTS[18400] = Fluid3D([12404,11745,12206,12676],0); -ELEMENTS[18401] = Fluid3D([11672,11204,11088,12119],0); -ELEMENTS[18402] = Fluid3D([12119,11672,12373,11088],0); -ELEMENTS[18403] = Fluid3D([12206,11745,11299,12069],0); -ELEMENTS[18404] = Fluid3D([12373,11672,12304,11715],0); -ELEMENTS[18405] = Fluid3D([12304,11745,12404,12676],0); -ELEMENTS[18406] = Fluid3D([11204,11705,10743,10640],0); -ELEMENTS[18407] = Fluid3D([11330,11595,10930,10956],0); -ELEMENTS[18408] = Fluid3D([12404,11705,12119,12575],0); -ELEMENTS[18409] = Fluid3D([11705,12119,12575,11760],0); -ELEMENTS[18410] = Fluid3D([11705,12119,11760,11204],0); -ELEMENTS[18411] = Fluid3D([12119,12404,12575,13138],0); -ELEMENTS[18412] = Fluid3D([12119,12404,13138,12373],0); -ELEMENTS[18413] = Fluid3D([11705,12404,12206,12575],0); -ELEMENTS[18414] = Fluid3D([12119,12575,11760,12331],0); -ELEMENTS[18415] = Fluid3D([12119,12575,12331,13138],0); -ELEMENTS[18416] = Fluid3D([11760,12119,12331,11917],0); -ELEMENTS[18417] = Fluid3D([11760,12119,11917,11204],0); -ELEMENTS[18418] = Fluid3D([11705,12206,11299,11801],0); -ELEMENTS[18419] = Fluid3D([11299,11705,11801,10640],0); -ELEMENTS[18420] = Fluid3D([11299,11705,10640,10743],0); -ELEMENTS[18421] = Fluid3D([11705,12206,11801,12575],0); -ELEMENTS[18422] = Fluid3D([12206,11299,11801,11898],0); -ELEMENTS[18423] = Fluid3D([11299,11801,11898,10990],0); -ELEMENTS[18424] = Fluid3D([11299,11801,10990,10640],0); -ELEMENTS[18425] = Fluid3D([11595,11791,12345,11802],0); -ELEMENTS[18426] = Fluid3D([12345,12542,12259,13148],0); -ELEMENTS[18427] = Fluid3D([12345,12308,12542,13197],0); -ELEMENTS[18428] = Fluid3D([12542,12345,13197,13148],0); -ELEMENTS[18429] = Fluid3D([12345,12308,13197,12987],0); -ELEMENTS[18430] = Fluid3D([13197,12345,12987,13438],0); -ELEMENTS[18431] = Fluid3D([12987,13197,13438,13697],0); -ELEMENTS[18432] = Fluid3D([12308,13197,12987,12845],0); -ELEMENTS[18433] = Fluid3D([12345,12987,13438,12759],0); -ELEMENTS[18434] = Fluid3D([12987,13438,12759,13566],0); -ELEMENTS[18435] = Fluid3D([12345,12987,12759,11791],0); -ELEMENTS[18436] = Fluid3D([13197,12345,13438,13148],0); -ELEMENTS[18437] = Fluid3D([11802,12304,11715,12552],0); -ELEMENTS[18438] = Fluid3D([11715,11802,12552,11762],0); -ELEMENTS[18439] = Fluid3D([11715,11802,11762,10916],0); -ELEMENTS[18440] = Fluid3D([11802,11762,10916,11328],0); -ELEMENTS[18441] = Fluid3D([12552,11715,11762,12233],0); -ELEMENTS[18442] = Fluid3D([12552,11715,12233,12373],0); -ELEMENTS[18443] = Fluid3D([11715,11762,12233,11218],0); -ELEMENTS[18444] = Fluid3D([11715,11762,11218,10916],0); -ELEMENTS[18445] = Fluid3D([11802,12552,11762,12382],0); -ELEMENTS[18446] = Fluid3D([11762,11802,12382,11328],0); -ELEMENTS[18447] = Fluid3D([12233,11715,11218,11697],0); -ELEMENTS[18448] = Fluid3D([12233,11715,11697,12373],0); -ELEMENTS[18449] = Fluid3D([11715,11218,11697,11088],0); -ELEMENTS[18450] = Fluid3D([11697,11715,11088,12373],0); -ELEMENTS[18451] = Fluid3D([11218,11697,11088,10870],0); -ELEMENTS[18452] = Fluid3D([11697,11088,10870,11617],0); -ELEMENTS[18453] = Fluid3D([11697,11088,11617,12119],0); -ELEMENTS[18454] = Fluid3D([10870,11697,11617,11744],0); -ELEMENTS[18455] = Fluid3D([10870,11697,11744,11611],0); -ELEMENTS[18456] = Fluid3D([10870,11697,11611,11218],0); -ELEMENTS[18457] = Fluid3D([11697,11611,11218,12233],0); -ELEMENTS[18458] = Fluid3D([11611,11218,12233,11737],0); -ELEMENTS[18459] = Fluid3D([11611,11218,11737,10846],0); -ELEMENTS[18460] = Fluid3D([11611,11218,10846,10870],0); -ELEMENTS[18461] = Fluid3D([11697,11617,11744,12351],0); -ELEMENTS[18462] = Fluid3D([11697,11617,12351,12119],0); -ELEMENTS[18463] = Fluid3D([11737,11611,10846,11614],0); -ELEMENTS[18464] = Fluid3D([11218,11737,10846,10886],0); -ELEMENTS[18465] = Fluid3D([11611,10846,11614,11019],0); -ELEMENTS[18466] = Fluid3D([11611,10846,11019,10870],0); -ELEMENTS[18467] = Fluid3D([11737,11611,11614,12473],0); -ELEMENTS[18468] = Fluid3D([10846,11218,10886,10191],0); -ELEMENTS[18469] = Fluid3D([11737,11611,12473,12233],0); -ELEMENTS[18470] = Fluid3D([10846,11218,10191,10870],0); -ELEMENTS[18471] = Fluid3D([11218,11737,10886,11762],0); -ELEMENTS[18472] = Fluid3D([11088,10870,11617,10098],0); -ELEMENTS[18473] = Fluid3D([11697,11744,11611,12486],0); -ELEMENTS[18474] = Fluid3D([11697,11744,12486,12351],0); -ELEMENTS[18475] = Fluid3D([11614,11611,11019,12161],0); -ELEMENTS[18476] = Fluid3D([11218,10886,10191,10916],0); -ELEMENTS[18477] = Fluid3D([11614,11611,12161,12473],0); -ELEMENTS[18478] = Fluid3D([11744,10870,11611,11019],0); -ELEMENTS[18479] = Fluid3D([11697,11611,12233,12486],0); -ELEMENTS[18480] = Fluid3D([11611,12233,12486,12473],0); -ELEMENTS[18481] = Fluid3D([12233,11697,12486,12373],0); -ELEMENTS[18482] = Fluid3D([12233,12486,12473,13139],0); -ELEMENTS[18483] = Fluid3D([12233,12486,13139,12373],0); -ELEMENTS[18484] = Fluid3D([12486,12473,13139,13156],0); -ELEMENTS[18485] = Fluid3D([13139,12486,13156,13232],0); -ELEMENTS[18486] = Fluid3D([13139,12486,13232,12373],0); -ELEMENTS[18487] = Fluid3D([12486,12473,13156,12161],0); -ELEMENTS[18488] = Fluid3D([12486,11611,12473,12161],0); -ELEMENTS[18489] = Fluid3D([12486,13156,13232,12783],0); -ELEMENTS[18490] = Fluid3D([12486,13156,12783,12161],0); -ELEMENTS[18491] = Fluid3D([11611,11019,12161,11744],0); -ELEMENTS[18492] = Fluid3D([10886,10846,10191,10037],0); -ELEMENTS[18493] = Fluid3D([10846,10191,10037,9839],0); -ELEMENTS[18494] = Fluid3D([10846,10191,9839,10870],0); -ELEMENTS[18495] = Fluid3D([11802,12552,12382,12759],0); -ELEMENTS[18496] = Fluid3D([12552,12382,12759,13264],0); -ELEMENTS[18497] = Fluid3D([12759,12552,13264,13341],0); -ELEMENTS[18498] = Fluid3D([12759,12552,13341,12304],0); -ELEMENTS[18499] = Fluid3D([12382,12759,13264,13566],0); -ELEMENTS[18500] = Fluid3D([11802,12552,12759,12304],0); -ELEMENTS[18501] = Fluid3D([13264,12759,13341,13438],0); -ELEMENTS[18502] = Fluid3D([12382,11802,12759,11791],0); -ELEMENTS[18503] = Fluid3D([12552,13264,13341,13332],0); -ELEMENTS[18504] = Fluid3D([13341,12552,13332,12373],0); -ELEMENTS[18505] = Fluid3D([12552,13264,13332,12737],0); -ELEMENTS[18506] = Fluid3D([12552,12382,13264,12737],0); -ELEMENTS[18507] = Fluid3D([12759,13264,13566,13438],0); -ELEMENTS[18508] = Fluid3D([13264,13341,13332,14027],0); -ELEMENTS[18509] = Fluid3D([13341,13332,14027,13715],0); -ELEMENTS[18510] = Fluid3D([13341,13332,13715,12373],0); -ELEMENTS[18511] = Fluid3D([10886,10846,10037,10977],0); -ELEMENTS[18512] = Fluid3D([10886,10846,10977,11737],0); -ELEMENTS[18513] = Fluid3D([10846,10037,10977,10401],0); -ELEMENTS[18514] = Fluid3D([10846,10037,10401,9839],0); -ELEMENTS[18515] = Fluid3D([10977,10846,10401,11614],0); -ELEMENTS[18516] = Fluid3D([10846,11737,11614,10977],0); -ELEMENTS[18517] = Fluid3D([13264,13332,12737,13754],0); -ELEMENTS[18518] = Fluid3D([12737,13264,13754,13177],0); -ELEMENTS[18519] = Fluid3D([11218,12233,11737,11762],0); -ELEMENTS[18520] = Fluid3D([11744,11611,12486,12161],0); -ELEMENTS[18521] = Fluid3D([10846,11614,11019,10401],0); -ELEMENTS[18522] = Fluid3D([13156,13232,12783,13761],0); -ELEMENTS[18523] = Fluid3D([12783,13156,13761,13172],0); -ELEMENTS[18524] = Fluid3D([12783,13156,13172,12161],0); -ELEMENTS[18525] = Fluid3D([11617,10870,11744,10894],0); -ELEMENTS[18526] = Fluid3D([10870,11744,10894,11019],0); -ELEMENTS[18527] = Fluid3D([11744,11617,10894,11776],0); -ELEMENTS[18528] = Fluid3D([11744,11617,11776,12351],0); -ELEMENTS[18529] = Fluid3D([10894,11744,11776,11704],0); -ELEMENTS[18530] = Fluid3D([10894,11744,11704,11019],0); -ELEMENTS[18531] = Fluid3D([11744,11776,11704,12783],0); -ELEMENTS[18532] = Fluid3D([11019,11614,12161,11349],0); -ELEMENTS[18533] = Fluid3D([11614,12161,11349,12448],0); -ELEMENTS[18534] = Fluid3D([11614,12161,12448,12473],0); -ELEMENTS[18535] = Fluid3D([10191,10037,9839,8884],0); -ELEMENTS[18536] = Fluid3D([13332,12552,12737,12233],0); -ELEMENTS[18537] = Fluid3D([13156,13139,13232,13809],0); -ELEMENTS[18538] = Fluid3D([13139,13232,13809,13715],0); -ELEMENTS[18539] = Fluid3D([13156,13139,13809,13475],0); -ELEMENTS[18540] = Fluid3D([13156,13139,13475,12473],0); -ELEMENTS[18541] = Fluid3D([13139,13809,13475,13754],0); -ELEMENTS[18542] = Fluid3D([12486,11697,12351,12373],0); -ELEMENTS[18543] = Fluid3D([13232,12486,12783,12351],0); -ELEMENTS[18544] = Fluid3D([11614,11737,12473,12301],0); -ELEMENTS[18545] = Fluid3D([11737,12473,12301,12737],0); -ELEMENTS[18546] = Fluid3D([11614,11737,12301,10977],0); -ELEMENTS[18547] = Fluid3D([13232,12783,13761,13512],0); -ELEMENTS[18548] = Fluid3D([13148,13289,13562,13802],0); -ELEMENTS[18549] = Fluid3D([13562,13148,13802,14056],0); -ELEMENTS[18550] = Fluid3D([13148,13289,13802,13559],0); -ELEMENTS[18551] = Fluid3D([13438,12345,12759,12676],0); -ELEMENTS[18552] = Fluid3D([12676,12841,12069,13312],0); -ELEMENTS[18553] = Fluid3D([12308,12542,13197,12975],0); -ELEMENTS[18554] = Fluid3D([12542,13197,12975,13559],0); -ELEMENTS[18555] = Fluid3D([12308,12542,12975,11508],0); -ELEMENTS[18556] = Fluid3D([13197,12308,12975,12845],0); -ELEMENTS[18557] = Fluid3D([11864,11706,10956,12069],0); -ELEMENTS[18558] = Fluid3D([11328,11791,11802,12382],0); -ELEMENTS[18559] = Fluid3D([10902,10930,11791,10824],0); -ELEMENTS[18560] = Fluid3D([10281,10555,11328,10621],0); -ELEMENTS[18561] = Fluid3D([10364,10902,11401,10824],0); -ELEMENTS[18562] = Fluid3D([10364,10902,10824,9950],0); -ELEMENTS[18563] = Fluid3D([11401,10364,10824,10914],0); -ELEMENTS[18564] = Fluid3D([10902,11401,10824,11791],0); -ELEMENTS[18565] = Fluid3D([10035,10202,11000,10232],0); -ELEMENTS[18566] = Fluid3D([10035,10202,10232,9129],0); -ELEMENTS[18567] = Fluid3D([11000,10035,10232,10830],0); -ELEMENTS[18568] = Fluid3D([10202,11000,10232,10778],0); -ELEMENTS[18569] = Fluid3D([12404,12373,12304,13116],0); -ELEMENTS[18570] = Fluid3D([12404,12373,13116,13138],0); -ELEMENTS[18571] = Fluid3D([12373,12304,13116,13341],0); -ELEMENTS[18572] = Fluid3D([12304,13116,13341,12676],0); -ELEMENTS[18573] = Fluid3D([11729,12511,11921,13073],0); -ELEMENTS[18574] = Fluid3D([9311,9462,9238,8497],0); -ELEMENTS[18575] = Fluid3D([10231,10054,10271,9127],0); -ELEMENTS[18576] = Fluid3D([11000,11729,10830,11671],0); -ELEMENTS[18577] = Fluid3D([12480,11463,12686,12105],0); -ELEMENTS[18578] = Fluid3D([12480,11463,12105,11359],0); -ELEMENTS[18579] = Fluid3D([12686,12480,12105,13045],0); -ELEMENTS[18580] = Fluid3D([12105,12686,13045,12802],0); -ELEMENTS[18581] = Fluid3D([12686,13045,12802,13553],0); -ELEMENTS[18582] = Fluid3D([12802,12686,13553,13596],0); -ELEMENTS[18583] = Fluid3D([12105,12686,12802,12068],0); -ELEMENTS[18584] = Fluid3D([12686,12802,12068,12678],0); -ELEMENTS[18585] = Fluid3D([13553,12802,13596,13527],0); -ELEMENTS[18586] = Fluid3D([13553,12802,13527,13045],0); -ELEMENTS[18587] = Fluid3D([13527,13553,13045,13336],0); -ELEMENTS[18588] = Fluid3D([12802,13527,13045,12378],0); -ELEMENTS[18589] = Fluid3D([12686,13045,13553,13247],0); -ELEMENTS[18590] = Fluid3D([13553,12686,13247,13175],0); -ELEMENTS[18591] = Fluid3D([12105,12686,12068,11463],0); -ELEMENTS[18592] = Fluid3D([12686,12068,11463,12383],0); -ELEMENTS[18593] = Fluid3D([12686,13045,13247,12480],0); -ELEMENTS[18594] = Fluid3D([13247,12686,12480,12537],0); -ELEMENTS[18595] = Fluid3D([12480,13247,12537,13149],0); -ELEMENTS[18596] = Fluid3D([13045,13247,12480,13336],0); -ELEMENTS[18597] = Fluid3D([13045,13247,13336,13553],0); -ELEMENTS[18598] = Fluid3D([13247,12480,13336,13149],0); -ELEMENTS[18599] = Fluid3D([12480,13045,13336,12459],0); -ELEMENTS[18600] = Fluid3D([13336,12480,12459,12794],0); -ELEMENTS[18601] = Fluid3D([12480,12459,12794,11850],0); -ELEMENTS[18602] = Fluid3D([12480,13045,12459,12105],0); -ELEMENTS[18603] = Fluid3D([13247,12686,12537,13175],0); -ELEMENTS[18604] = Fluid3D([12068,12105,11463,11327],0); -ELEMENTS[18605] = Fluid3D([11463,12068,11327,11794],0); -ELEMENTS[18606] = Fluid3D([11463,12068,11794,12383],0); -ELEMENTS[18607] = Fluid3D([12068,11794,12383,12678],0); -ELEMENTS[18608] = Fluid3D([11794,12383,12678,12323],0); -ELEMENTS[18609] = Fluid3D([11794,12383,12323,11206],0); -ELEMENTS[18610] = Fluid3D([11794,11463,12383,11522],0); -ELEMENTS[18611] = Fluid3D([12068,11794,12678,12080],0); -ELEMENTS[18612] = Fluid3D([12068,11794,12080,11254],0); -ELEMENTS[18613] = Fluid3D([12068,11794,11254,11327],0); -ELEMENTS[18614] = Fluid3D([12080,12068,11254,12187],0); -ELEMENTS[18615] = Fluid3D([11254,12068,11327,12187],0); -ELEMENTS[18616] = Fluid3D([11794,12383,11206,11522],0); -ELEMENTS[18617] = Fluid3D([12480,12459,11850,11359],0); -ELEMENTS[18618] = Fluid3D([12105,11463,11327,11359],0); -ELEMENTS[18619] = Fluid3D([12650,12896,12127,13055],0); -ELEMENTS[18620] = Fluid3D([12650,12896,13055,13711],0); -ELEMENTS[18621] = Fluid3D([12896,12127,13055,12901],0); -ELEMENTS[18622] = Fluid3D([12896,12127,12901,11981],0); -ELEMENTS[18623] = Fluid3D([13055,12896,12901,14064],0); -ELEMENTS[18624] = Fluid3D([12127,13055,12901,12557],0); -ELEMENTS[18625] = Fluid3D([13055,12901,12557,13481],0); -ELEMENTS[18626] = Fluid3D([12901,12127,12557,12124],0); -ELEMENTS[18627] = Fluid3D([12901,12127,12124,11981],0); -ELEMENTS[18628] = Fluid3D([12127,12557,12124,11566],0); -ELEMENTS[18629] = Fluid3D([12557,12124,11566,11882],0); -ELEMENTS[18630] = Fluid3D([11566,12557,11882,12256],0); -ELEMENTS[18631] = Fluid3D([11566,12557,12256,12127],0); -ELEMENTS[18632] = Fluid3D([12127,13055,12557,12582],0); -ELEMENTS[18633] = Fluid3D([12557,12124,11882,12757],0); -ELEMENTS[18634] = Fluid3D([12124,11882,12757,12024],0); -ELEMENTS[18635] = Fluid3D([11882,12757,12024,12436],0); -ELEMENTS[18636] = Fluid3D([11882,12757,12436,12827],0); -ELEMENTS[18637] = Fluid3D([11882,12757,12827,12557],0); -ELEMENTS[18638] = Fluid3D([12557,12124,12757,12901],0); -ELEMENTS[18639] = Fluid3D([12757,12436,12827,13105],0); -ELEMENTS[18640] = Fluid3D([12757,12436,13105,12024],0); -ELEMENTS[18641] = Fluid3D([13105,12757,12024,13191],0); -ELEMENTS[18642] = Fluid3D([12827,12757,13105,13531],0); -ELEMENTS[18643] = Fluid3D([12757,13105,13531,13595],0); -ELEMENTS[18644] = Fluid3D([12757,13105,13595,13191],0); -ELEMENTS[18645] = Fluid3D([12827,12757,13531,12557],0); -ELEMENTS[18646] = Fluid3D([12124,11882,12024,11129],0); -ELEMENTS[18647] = Fluid3D([12124,11882,11129,11566],0); -ELEMENTS[18648] = Fluid3D([11882,12024,11129,11352],0); -ELEMENTS[18649] = Fluid3D([11129,11882,11352,11022],0); -ELEMENTS[18650] = Fluid3D([11129,11882,11022,11566],0); -ELEMENTS[18651] = Fluid3D([11882,12024,11352,12436],0); -ELEMENTS[18652] = Fluid3D([12024,11129,11352,11003],0); -ELEMENTS[18653] = Fluid3D([11129,11352,11003,10414],0); -ELEMENTS[18654] = Fluid3D([11352,12024,11003,11731],0); -ELEMENTS[18655] = Fluid3D([11352,12024,11731,12436],0); -ELEMENTS[18656] = Fluid3D([12024,11129,11003,11394],0); -ELEMENTS[18657] = Fluid3D([11129,11003,11394,10390],0); -ELEMENTS[18658] = Fluid3D([11129,11003,10390,10414],0); -ELEMENTS[18659] = Fluid3D([12024,11129,11394,12124],0); -ELEMENTS[18660] = Fluid3D([11129,11352,10414,11022],0); -ELEMENTS[18661] = Fluid3D([12901,12557,13481,12757],0); -ELEMENTS[18662] = Fluid3D([11882,11352,11022,11742],0); -ELEMENTS[18663] = Fluid3D([11352,11022,11742,10777],0); -ELEMENTS[18664] = Fluid3D([11022,11742,10777,11040],0); -ELEMENTS[18665] = Fluid3D([11882,11352,11742,12436],0); -ELEMENTS[18666] = Fluid3D([11022,11882,11742,11809],0); -ELEMENTS[18667] = Fluid3D([11882,11742,11809,12827],0); -ELEMENTS[18668] = Fluid3D([11022,11882,11809,11566],0); -ELEMENTS[18669] = Fluid3D([11742,10777,11040,11376],0); -ELEMENTS[18670] = Fluid3D([11742,10777,11376,11579],0); -ELEMENTS[18671] = Fluid3D([11040,11742,11376,11984],0); -ELEMENTS[18672] = Fluid3D([10777,11040,11376,10360],0); -ELEMENTS[18673] = Fluid3D([10777,11040,10360,10066],0); -ELEMENTS[18674] = Fluid3D([11040,11742,11984,11809],0); -ELEMENTS[18675] = Fluid3D([10777,11040,10066,11022],0); -ELEMENTS[18676] = Fluid3D([11742,10777,11579,11352],0); -ELEMENTS[18677] = Fluid3D([11352,11022,10777,10414],0); -ELEMENTS[18678] = Fluid3D([11022,11742,11040,11809],0); -ELEMENTS[18679] = Fluid3D([12127,12650,13055,12582],0); -ELEMENTS[18680] = Fluid3D([12124,12127,11566,11267],0); -ELEMENTS[18681] = Fluid3D([11566,12124,11267,11129],0); -ELEMENTS[18682] = Fluid3D([12127,11566,11267,11524],0); -ELEMENTS[18683] = Fluid3D([12124,12127,11267,11981],0); -ELEMENTS[18684] = Fluid3D([13055,12901,13481,14064],0); -ELEMENTS[18685] = Fluid3D([11003,11352,11731,10769],0); -ELEMENTS[18686] = Fluid3D([11352,11731,10769,11579],0); -ELEMENTS[18687] = Fluid3D([11003,11352,10769,10414],0); -ELEMENTS[18688] = Fluid3D([11731,11003,10769,11005],0); -ELEMENTS[18689] = Fluid3D([11003,10769,11005,10085],0); -ELEMENTS[18690] = Fluid3D([10769,11005,10085,10169],0); -ELEMENTS[18691] = Fluid3D([11005,10085,10169,10132],0); -ELEMENTS[18692] = Fluid3D([11731,11003,11005,11812],0); -ELEMENTS[18693] = Fluid3D([11731,11003,11812,12024],0); -ELEMENTS[18694] = Fluid3D([10085,10169,10132,9340],0); -ELEMENTS[18695] = Fluid3D([10132,10085,9340,9470],0); -ELEMENTS[18696] = Fluid3D([10085,10169,9340,9628],0); -ELEMENTS[18697] = Fluid3D([10085,10169,9628,10769],0); -ELEMENTS[18698] = Fluid3D([10132,10085,9470,10477],0); -ELEMENTS[18699] = Fluid3D([10132,10085,10477,11005],0); -ELEMENTS[18700] = Fluid3D([10085,9470,10477,10390],0); -ELEMENTS[18701] = Fluid3D([11005,11731,11812,12221],0); -ELEMENTS[18702] = Fluid3D([10769,11005,10169,11255],0); -ELEMENTS[18703] = Fluid3D([11005,10169,11255,10927],0); -ELEMENTS[18704] = Fluid3D([10769,11005,11255,11731],0); -ELEMENTS[18705] = Fluid3D([10169,11255,10927,10354],0); -ELEMENTS[18706] = Fluid3D([11255,11005,10927,12221],0); -ELEMENTS[18707] = Fluid3D([10169,10769,11255,10766],0); -ELEMENTS[18708] = Fluid3D([10769,11255,10766,11579],0); -ELEMENTS[18709] = Fluid3D([10169,10769,10766,9628],0); -ELEMENTS[18710] = Fluid3D([11255,10169,10766,10354],0); -ELEMENTS[18711] = Fluid3D([11005,10169,10927,10132],0); -ELEMENTS[18712] = Fluid3D([11005,11003,10085,10477],0); -ELEMENTS[18713] = Fluid3D([11003,10769,10085,10414],0); -ELEMENTS[18714] = Fluid3D([9470,10132,10477,9970],0); -ELEMENTS[18715] = Fluid3D([10477,9470,9970,9812],0); -ELEMENTS[18716] = Fluid3D([9970,10477,9812,10725],0); -ELEMENTS[18717] = Fluid3D([9812,9970,10725,10271],0); -ELEMENTS[18718] = Fluid3D([9470,10132,9970,9617],0); -ELEMENTS[18719] = Fluid3D([10132,9970,9617,10536],0); -ELEMENTS[18720] = Fluid3D([10132,10477,9970,10943],0); -ELEMENTS[18721] = Fluid3D([10477,9970,10943,10725],0); -ELEMENTS[18722] = Fluid3D([10132,10477,10943,11005],0); -ELEMENTS[18723] = Fluid3D([9970,10132,10943,10536],0); -ELEMENTS[18724] = Fluid3D([10477,9470,9812,10390],0); -ELEMENTS[18725] = Fluid3D([9470,9970,9812,8860],0); -ELEMENTS[18726] = Fluid3D([10477,9812,10725,10716],0); -ELEMENTS[18727] = Fluid3D([10477,9812,10716,10390],0); -ELEMENTS[18728] = Fluid3D([9812,10725,10716,10830],0); -ELEMENTS[18729] = Fluid3D([10725,10477,10716,11459],0); -ELEMENTS[18730] = Fluid3D([10725,10477,11459,10943],0); -ELEMENTS[18731] = Fluid3D([10716,10725,11459,11450],0); -ELEMENTS[18732] = Fluid3D([10725,11459,11450,11665],0); -ELEMENTS[18733] = Fluid3D([11459,11450,11665,12317],0); -ELEMENTS[18734] = Fluid3D([11450,11665,12317,12190],0); -ELEMENTS[18735] = Fluid3D([11450,11665,12190,11030],0); -ELEMENTS[18736] = Fluid3D([10716,10725,11450,10830],0); -ELEMENTS[18737] = Fluid3D([11459,11450,12317,11797],0); -ELEMENTS[18738] = Fluid3D([11450,12317,11797,12257],0); -ELEMENTS[18739] = Fluid3D([12317,11459,11797,11812],0); -ELEMENTS[18740] = Fluid3D([11459,11450,11797,10716],0); -ELEMENTS[18741] = Fluid3D([11450,12317,12257,12190],0); -ELEMENTS[18742] = Fluid3D([10725,11459,11665,10943],0); -ELEMENTS[18743] = Fluid3D([11665,12317,12190,12431],0); -ELEMENTS[18744] = Fluid3D([11665,12317,12431,12318],0); -ELEMENTS[18745] = Fluid3D([12190,11665,12431,12567],0); -ELEMENTS[18746] = Fluid3D([12431,12190,12567,12941],0); -ELEMENTS[18747] = Fluid3D([12190,12567,12941,13073],0); -ELEMENTS[18748] = Fluid3D([12317,12190,12431,12941],0); -ELEMENTS[18749] = Fluid3D([12317,12190,12941,12257],0); -ELEMENTS[18750] = Fluid3D([12431,12317,12941,12810],0); -ELEMENTS[18751] = Fluid3D([12431,12317,12810,12318],0); -ELEMENTS[18752] = Fluid3D([12317,12941,12810,13299],0); -ELEMENTS[18753] = Fluid3D([12317,12810,12318,11812],0); -ELEMENTS[18754] = Fluid3D([12941,12317,12257,13299],0); -ELEMENTS[18755] = Fluid3D([12190,12941,12257,12541],0); -ELEMENTS[18756] = Fluid3D([12941,12257,12541,13299],0); -ELEMENTS[18757] = Fluid3D([11665,11459,12317,12318],0); -ELEMENTS[18758] = Fluid3D([10477,10716,11459,11394],0); -ELEMENTS[18759] = Fluid3D([11450,10725,11665,11030],0); -ELEMENTS[18760] = Fluid3D([9340,10132,9470,9617],0); -ELEMENTS[18761] = Fluid3D([11003,11005,11812,10477],0); -ELEMENTS[18762] = Fluid3D([12557,13055,13481,13090],0); -ELEMENTS[18763] = Fluid3D([10169,10132,9340,9530],0); -ELEMENTS[18764] = Fluid3D([12757,12124,12024,12299],0); -ELEMENTS[18765] = Fluid3D([12024,12757,12299,13191],0); -ELEMENTS[18766] = Fluid3D([12757,12299,13191,12901],0); -ELEMENTS[18767] = Fluid3D([12757,12124,12299,12901],0); -ELEMENTS[18768] = Fluid3D([12124,12024,12299,11394],0); -ELEMENTS[18769] = Fluid3D([12436,11882,12827,11742],0); -ELEMENTS[18770] = Fluid3D([10085,9340,9470,9148],0); -ELEMENTS[18771] = Fluid3D([10085,9340,9148,9628],0); -ELEMENTS[18772] = Fluid3D([9470,10085,9148,10390],0); -ELEMENTS[18773] = Fluid3D([9340,9470,9148,8765],0); -ELEMENTS[18774] = Fluid3D([12268,12730,11778,12273],0); -ELEMENTS[18775] = Fluid3D([12268,12730,12273,13334],0); -ELEMENTS[18776] = Fluid3D([12730,11778,12273,12275],0); -ELEMENTS[18777] = Fluid3D([12730,11778,12275,12384],0); -ELEMENTS[18778] = Fluid3D([12273,12730,12275,12732],0); -ELEMENTS[18779] = Fluid3D([12275,12273,12732,12333],0); -ELEMENTS[18780] = Fluid3D([12730,11778,12384,12465],0); -ELEMENTS[18781] = Fluid3D([12273,12730,12732,13334],0); -ELEMENTS[18782] = Fluid3D([11778,12268,12273,11284],0); -ELEMENTS[18783] = Fluid3D([11778,12273,12275,11238],0); -ELEMENTS[18784] = Fluid3D([12273,12275,11238,11840],0); -ELEMENTS[18785] = Fluid3D([11238,12273,11840,11104],0); -ELEMENTS[18786] = Fluid3D([11840,11238,11104,11009],0); -ELEMENTS[18787] = Fluid3D([11778,12273,11238,11284],0); -ELEMENTS[18788] = Fluid3D([12275,11778,11238,11776],0); -ELEMENTS[18789] = Fluid3D([12273,12275,11840,12333],0); -ELEMENTS[18790] = Fluid3D([11840,12273,12333,11104],0); -ELEMENTS[18791] = Fluid3D([12333,11840,11104,11603],0); -ELEMENTS[18792] = Fluid3D([12333,11840,11603,12254],0); -ELEMENTS[18793] = Fluid3D([12333,11840,12254,12331],0); -ELEMENTS[18794] = Fluid3D([11603,12333,12254,12511],0); -ELEMENTS[18795] = Fluid3D([12275,12730,12384,13040],0); -ELEMENTS[18796] = Fluid3D([12275,12730,13040,12732],0); -ELEMENTS[18797] = Fluid3D([12730,12384,13040,13313],0); -ELEMENTS[18798] = Fluid3D([12384,12275,13040,11776],0); -ELEMENTS[18799] = Fluid3D([12384,12275,11776,11778],0); -ELEMENTS[18800] = Fluid3D([12275,11238,11840,11917],0); -ELEMENTS[18801] = Fluid3D([11981,12415,11894,12887],0); -ELEMENTS[18802] = Fluid3D([12415,11894,12887,12652],0); -ELEMENTS[18803] = Fluid3D([11894,11981,12887,11671],0); -ELEMENTS[18804] = Fluid3D([11981,12415,12887,12896],0); -ELEMENTS[18805] = Fluid3D([12887,12415,12652,13321],0); -ELEMENTS[18806] = Fluid3D([12652,12887,13321,13801],0); -ELEMENTS[18807] = Fluid3D([12887,12415,13321,12896],0); -ELEMENTS[18808] = Fluid3D([12415,11894,12652,11952],0); -ELEMENTS[18809] = Fluid3D([12415,12652,13321,12794],0); -ELEMENTS[18810] = Fluid3D([11894,12887,12652,12541],0); -ELEMENTS[18811] = Fluid3D([11850,11929,11359,12459],0); -ELEMENTS[18812] = Fluid3D([11284,11060,11952,10778],0); -ELEMENTS[18813] = Fluid3D([10909,10274,10593,9907],0); -ELEMENTS[18814] = Fluid3D([10274,10593,9907,9400],0); -ELEMENTS[18815] = Fluid3D([10909,10274,9907,10207],0); -ELEMENTS[18816] = Fluid3D([10593,10909,9907,10856],0); -ELEMENTS[18817] = Fluid3D([10909,9907,10856,10410],0); -ELEMENTS[18818] = Fluid3D([9907,10856,10410,9752],0); -ELEMENTS[18819] = Fluid3D([10856,10410,9752,11254],0); -ELEMENTS[18820] = Fluid3D([9907,10856,9752,9827],0); -ELEMENTS[18821] = Fluid3D([9907,10856,9827,10593],0); -ELEMENTS[18822] = Fluid3D([9752,9907,9827,9131],0); -ELEMENTS[18823] = Fluid3D([9827,9752,9131,8970],0); -ELEMENTS[18824] = Fluid3D([10593,10909,10856,11522],0); -ELEMENTS[18825] = Fluid3D([10856,9752,9827,10238],0); -ELEMENTS[18826] = Fluid3D([9827,10856,10238,10900],0); -ELEMENTS[18827] = Fluid3D([10856,9752,10238,11254],0); -ELEMENTS[18828] = Fluid3D([9752,9827,10238,8970],0); -ELEMENTS[18829] = Fluid3D([9827,10856,10900,10593],0); -ELEMENTS[18830] = Fluid3D([10238,9827,10900,9745],0); -ELEMENTS[18831] = Fluid3D([9752,9907,9131,9289],0); -ELEMENTS[18832] = Fluid3D([9907,9131,9289,9286],0); -ELEMENTS[18833] = Fluid3D([9752,9907,9289,10410],0); -ELEMENTS[18834] = Fluid3D([9131,9752,9289,8487],0); -ELEMENTS[18835] = Fluid3D([10856,10238,10900,11206],0); -ELEMENTS[18836] = Fluid3D([10238,10900,11206,10530],0); -ELEMENTS[18837] = Fluid3D([11206,10238,10530,10676],0); -ELEMENTS[18838] = Fluid3D([11206,10238,10676,10709],0); -ELEMENTS[18839] = Fluid3D([10900,11206,10530,11398],0); -ELEMENTS[18840] = Fluid3D([10900,11206,11398,11750],0); -ELEMENTS[18841] = Fluid3D([10900,11206,11750,11522],0); -ELEMENTS[18842] = Fluid3D([10530,11206,10676,11770],0); -ELEMENTS[18843] = Fluid3D([11206,10530,11398,11770],0); -ELEMENTS[18844] = Fluid3D([10238,10530,10676,9745],0); -ELEMENTS[18845] = Fluid3D([10238,10530,9745,10900],0); -ELEMENTS[18846] = Fluid3D([11206,11398,11750,12323],0); -ELEMENTS[18847] = Fluid3D([11750,11206,12323,12383],0); -ELEMENTS[18848] = Fluid3D([12323,11750,12383,12465],0); -ELEMENTS[18849] = Fluid3D([11750,12383,12465,11522],0); -ELEMENTS[18850] = Fluid3D([11750,12383,11522,11206],0); -ELEMENTS[18851] = Fluid3D([12465,11750,11522,11778],0); -ELEMENTS[18852] = Fluid3D([11398,10900,11750,11432],0); -ELEMENTS[18853] = Fluid3D([10900,11750,11432,11122],0); -ELEMENTS[18854] = Fluid3D([10530,10900,11398,10595],0); -ELEMENTS[18855] = Fluid3D([10900,11398,10595,11432],0); -ELEMENTS[18856] = Fluid3D([11750,11432,11122,11778],0); -ELEMENTS[18857] = Fluid3D([11432,11122,11778,10848],0); -ELEMENTS[18858] = Fluid3D([11122,11778,10848,11284],0); -ELEMENTS[18859] = Fluid3D([11432,11122,10848,10900],0); -ELEMENTS[18860] = Fluid3D([11398,10530,10595,10931],0); -ELEMENTS[18861] = Fluid3D([10900,11750,11122,11522],0); -ELEMENTS[18862] = Fluid3D([11750,11122,11522,11778],0); -ELEMENTS[18863] = Fluid3D([11122,11522,11778,11284],0); -ELEMENTS[18864] = Fluid3D([11122,11522,11284,10593],0); -ELEMENTS[18865] = Fluid3D([11122,11522,10593,10856],0); -ELEMENTS[18866] = Fluid3D([11284,11122,10593,10848],0); -ELEMENTS[18867] = Fluid3D([11122,10593,10848,10900],0); -ELEMENTS[18868] = Fluid3D([10593,11122,10856,10900],0); -ELEMENTS[18869] = Fluid3D([11122,11522,10856,10900],0); -ELEMENTS[18870] = Fluid3D([11398,10530,10931,11770],0); -ELEMENTS[18871] = Fluid3D([11750,11398,11432,12306],0); -ELEMENTS[18872] = Fluid3D([11432,11750,12306,12465],0); -ELEMENTS[18873] = Fluid3D([11750,11398,12306,12323],0); -ELEMENTS[18874] = Fluid3D([10530,9745,10900,10595],0); -ELEMENTS[18875] = Fluid3D([10595,11398,10931,11704],0); -ELEMENTS[18876] = Fluid3D([10909,9907,10410,10207],0); -ELEMENTS[18877] = Fluid3D([10856,10909,10410,11463],0); -ELEMENTS[18878] = Fluid3D([10530,10595,10931,10073],0); -ELEMENTS[18879] = Fluid3D([10595,10931,10073,10506],0); -ELEMENTS[18880] = Fluid3D([10931,10530,10073,10428],0); -ELEMENTS[18881] = Fluid3D([10073,10595,10506,9514],0); -ELEMENTS[18882] = Fluid3D([10506,10073,9514,9536],0); -ELEMENTS[18883] = Fluid3D([10506,10073,9536,10245],0); -ELEMENTS[18884] = Fluid3D([9536,10506,10245,10100],0); -ELEMENTS[18885] = Fluid3D([9536,10506,10100,9929],0); -ELEMENTS[18886] = Fluid3D([9536,10506,9929,9514],0); -ELEMENTS[18887] = Fluid3D([10530,10595,10073,9745],0); -ELEMENTS[18888] = Fluid3D([10073,10530,9745,10428],0); -ELEMENTS[18889] = Fluid3D([10100,9536,9929,9319],0); -ELEMENTS[18890] = Fluid3D([10100,9536,9319,9467],0); -ELEMENTS[18891] = Fluid3D([10100,9536,9467,10245],0); -ELEMENTS[18892] = Fluid3D([9536,9929,9319,8966],0); -ELEMENTS[18893] = Fluid3D([9536,9929,8966,9514],0); -ELEMENTS[18894] = Fluid3D([9319,9536,8966,8457],0); -ELEMENTS[18895] = Fluid3D([9319,9536,8457,9467],0); -ELEMENTS[18896] = Fluid3D([9536,8966,8457,8831],0); -ELEMENTS[18897] = Fluid3D([9536,8966,8831,9514],0); -ELEMENTS[18898] = Fluid3D([8457,9536,8831,9055],0); -ELEMENTS[18899] = Fluid3D([8457,9536,9055,9467],0); -ELEMENTS[18900] = Fluid3D([9536,8831,9055,10073],0); -ELEMENTS[18901] = Fluid3D([9319,10100,9467,10401],0); -ELEMENTS[18902] = Fluid3D([10506,10073,10245,10931],0); -ELEMENTS[18903] = Fluid3D([10073,10595,9514,9745],0); -ELEMENTS[18904] = Fluid3D([10595,10931,10506,11704],0); -ELEMENTS[18905] = Fluid3D([10073,10931,10428,10245],0); -ELEMENTS[18906] = Fluid3D([9929,9319,8966,9839],0); -ELEMENTS[18907] = Fluid3D([9929,9319,9839,10100],0); -ELEMENTS[18908] = Fluid3D([9839,9929,10100,11019],0); -ELEMENTS[18909] = Fluid3D([9319,9839,10100,10401],0); -ELEMENTS[18910] = Fluid3D([10931,10530,10428,11770],0); -ELEMENTS[18911] = Fluid3D([10595,10506,9514,10894],0); -ELEMENTS[18912] = Fluid3D([10506,10245,10100,11349],0); -ELEMENTS[18913] = Fluid3D([8966,8457,8831,8064],0); -ELEMENTS[18914] = Fluid3D([8831,8966,8064,8628],0); -ELEMENTS[18915] = Fluid3D([8966,8457,8064,8344],0); -ELEMENTS[18916] = Fluid3D([8966,8457,8344,9319],0); -ELEMENTS[18917] = Fluid3D([8966,8064,8628,8296],0); -ELEMENTS[18918] = Fluid3D([8966,8064,8296,8344],0); -ELEMENTS[18919] = Fluid3D([8457,8064,8344,7705],0); -ELEMENTS[18920] = Fluid3D([8064,8628,8296,7726],0); -ELEMENTS[18921] = Fluid3D([8628,8296,7726,8143],0); -ELEMENTS[18922] = Fluid3D([8064,8344,7705,7501],0); -ELEMENTS[18923] = Fluid3D([8628,8296,8143,9115],0); -ELEMENTS[18924] = Fluid3D([8628,8296,9115,8966],0); -ELEMENTS[18925] = Fluid3D([8064,8344,7501,8296],0); -ELEMENTS[18926] = Fluid3D([8344,7705,7501,7451],0); -ELEMENTS[18927] = Fluid3D([7705,7501,7451,6892],0); -ELEMENTS[18928] = Fluid3D([8457,8064,7705,7628],0); -ELEMENTS[18929] = Fluid3D([8064,7705,7628,7501],0); -ELEMENTS[18930] = Fluid3D([8064,8628,7726,8120],0); -ELEMENTS[18931] = Fluid3D([8064,8628,8120,8831],0); -ELEMENTS[18932] = Fluid3D([8628,8120,8831,9046],0); -ELEMENTS[18933] = Fluid3D([8120,8064,8831,7628],0); -ELEMENTS[18934] = Fluid3D([8120,8064,7628,7726],0); -ELEMENTS[18935] = Fluid3D([8457,8831,8064,7628],0); -ELEMENTS[18936] = Fluid3D([8296,7726,8143,7213],0); -ELEMENTS[18937] = Fluid3D([8831,8966,8628,9514],0); -ELEMENTS[18938] = Fluid3D([8344,8457,7705,8427],0); -ELEMENTS[18939] = Fluid3D([8344,8457,8427,9319],0); -ELEMENTS[18940] = Fluid3D([8457,7705,8427,8273],0); -ELEMENTS[18941] = Fluid3D([8427,8457,8273,9467],0); -ELEMENTS[18942] = Fluid3D([8457,7705,8273,7560],0); -ELEMENTS[18943] = Fluid3D([7705,8273,7560,7586],0); -ELEMENTS[18944] = Fluid3D([7560,7705,7586,6918],0); -ELEMENTS[18945] = Fluid3D([8273,7560,7586,7359],0); -ELEMENTS[18946] = Fluid3D([7705,8273,7586,8427],0); -ELEMENTS[18947] = Fluid3D([8457,7705,7560,7628],0); -ELEMENTS[18948] = Fluid3D([7705,7560,7628,6892],0); -ELEMENTS[18949] = Fluid3D([7705,7560,6892,6918],0); -ELEMENTS[18950] = Fluid3D([7586,7560,6918,7359],0); -ELEMENTS[18951] = Fluid3D([8273,7560,7359,7716],0); -ELEMENTS[18952] = Fluid3D([8273,7560,7716,8457],0); -ELEMENTS[18953] = Fluid3D([7560,7359,7716,6874],0); -ELEMENTS[18954] = Fluid3D([7716,7560,6874,7628],0); -ELEMENTS[18955] = Fluid3D([7359,7716,6874,6902],0); -ELEMENTS[18956] = Fluid3D([7705,8344,8427,7451],0); -ELEMENTS[18957] = Fluid3D([8427,7705,7451,7586],0); -ELEMENTS[18958] = Fluid3D([7705,7451,7586,6918],0); -ELEMENTS[18959] = Fluid3D([8296,8064,7726,7501],0); -ELEMENTS[18960] = Fluid3D([7726,8628,8143,8466],0); -ELEMENTS[18961] = Fluid3D([8628,8143,8466,9145],0); -ELEMENTS[18962] = Fluid3D([8466,8628,9145,9221],0); -ELEMENTS[18963] = Fluid3D([8466,8628,9221,9046],0); -ELEMENTS[18964] = Fluid3D([9221,8466,9046,8871],0); -ELEMENTS[18965] = Fluid3D([9046,9221,8871,9827],0); -ELEMENTS[18966] = Fluid3D([8628,9145,9221,9514],0); -ELEMENTS[18967] = Fluid3D([9046,9221,9827,9745],0); -ELEMENTS[18968] = Fluid3D([9145,8466,9221,8871],0); -ELEMENTS[18969] = Fluid3D([8628,8143,9145,9115],0); -ELEMENTS[18970] = Fluid3D([9145,8628,9115,9514],0); -ELEMENTS[18971] = Fluid3D([8143,9145,9115,9238],0); -ELEMENTS[18972] = Fluid3D([9145,9115,9238,9971],0); -ELEMENTS[18973] = Fluid3D([9115,9238,9971,10098],0); -ELEMENTS[18974] = Fluid3D([9145,9115,9971,9514],0); -ELEMENTS[18975] = Fluid3D([9238,9145,9971,9378],0); -ELEMENTS[18976] = Fluid3D([9115,8143,9238,8166],0); -ELEMENTS[18977] = Fluid3D([9238,9145,9378,8402],0); -ELEMENTS[18978] = Fluid3D([8831,8457,9055,8111],0); -ELEMENTS[18979] = Fluid3D([8457,9055,8111,7716],0); -ELEMENTS[18980] = Fluid3D([8831,8457,8111,7628],0); -ELEMENTS[18981] = Fluid3D([8111,8831,7628,8019],0); -ELEMENTS[18982] = Fluid3D([7628,8111,8019,7716],0); -ELEMENTS[18983] = Fluid3D([8111,8019,7716,8658],0); -ELEMENTS[18984] = Fluid3D([7628,8111,7716,7560],0); -ELEMENTS[18985] = Fluid3D([8111,7716,7560,8457],0); -ELEMENTS[18986] = Fluid3D([8111,8019,8658,8831],0); -ELEMENTS[18987] = Fluid3D([7628,8111,7560,8457],0); -ELEMENTS[18988] = Fluid3D([9055,8831,8111,8658],0); -ELEMENTS[18989] = Fluid3D([8111,9055,8658,7716],0); -ELEMENTS[18990] = Fluid3D([8296,8143,9115,8166],0); -ELEMENTS[18991] = Fluid3D([10073,9514,9536,8831],0); -ELEMENTS[18992] = Fluid3D([11398,11432,12306,11704],0); -ELEMENTS[18993] = Fluid3D([10506,10100,9929,11019],0); -ELEMENTS[18994] = Fluid3D([10506,10100,11019,11349],0); -ELEMENTS[18995] = Fluid3D([9907,9827,9131,9400],0); -ELEMENTS[18996] = Fluid3D([10073,9536,10245,9055],0); -ELEMENTS[18997] = Fluid3D([11778,11432,10848,11776],0); -ELEMENTS[18998] = Fluid3D([10777,11376,11579,10745],0); -ELEMENTS[18999] = Fluid3D([11579,10777,10745,10769],0); -ELEMENTS[19000] = Fluid3D([10777,11376,10745,10360],0); -ELEMENTS[19001] = Fluid3D([11376,11579,10745,11691],0); -ELEMENTS[19002] = Fluid3D([11376,11579,11691,12321],0); -ELEMENTS[19003] = Fluid3D([11579,11691,12321,12574],0); -ELEMENTS[19004] = Fluid3D([10745,11376,11691,10955],0); -ELEMENTS[19005] = Fluid3D([10745,11376,10955,10360],0); -ELEMENTS[19006] = Fluid3D([11691,10745,10955,10904],0); -ELEMENTS[19007] = Fluid3D([11691,10745,10904,11455],0); -ELEMENTS[19008] = Fluid3D([10745,10904,11455,10182],0); -ELEMENTS[19009] = Fluid3D([10745,10955,10904,9734],0); -ELEMENTS[19010] = Fluid3D([10745,10955,9734,10360],0); -ELEMENTS[19011] = Fluid3D([10955,10904,9734,10483],0); -ELEMENTS[19012] = Fluid3D([9734,10955,10483,9927],0); -ELEMENTS[19013] = Fluid3D([10955,10904,10483,11618],0); -ELEMENTS[19014] = Fluid3D([10904,9734,10483,9932],0); -ELEMENTS[19015] = Fluid3D([11376,11691,10955,11925],0); -ELEMENTS[19016] = Fluid3D([11691,10955,11925,11618],0); -ELEMENTS[19017] = Fluid3D([11376,11691,11925,12321],0); -ELEMENTS[19018] = Fluid3D([10483,10955,11618,11067],0); -ELEMENTS[19019] = Fluid3D([10483,10955,11067,9927],0); -ELEMENTS[19020] = Fluid3D([10955,11618,11067,11925],0); -ELEMENTS[19021] = Fluid3D([11067,10955,11925,11076],0); -ELEMENTS[19022] = Fluid3D([11067,10955,11076,9927],0); -ELEMENTS[19023] = Fluid3D([10955,11925,11076,11376],0); -ELEMENTS[19024] = Fluid3D([11076,10955,11376,10360],0); -ELEMENTS[19025] = Fluid3D([11376,11076,10360,11040],0); -ELEMENTS[19026] = Fluid3D([11925,11076,11376,11984],0); -ELEMENTS[19027] = Fluid3D([11376,11076,11040,11984],0); -ELEMENTS[19028] = Fluid3D([10904,11455,10182,10821],0); -ELEMENTS[19029] = Fluid3D([10182,10904,10821,9932],0); -ELEMENTS[19030] = Fluid3D([11455,10182,10821,10766],0); -ELEMENTS[19031] = Fluid3D([11455,10182,10766,10745],0); -ELEMENTS[19032] = Fluid3D([10904,11455,10821,11553],0); -ELEMENTS[19033] = Fluid3D([10904,11455,11553,11691],0); -ELEMENTS[19034] = Fluid3D([11455,10821,11553,11644],0); -ELEMENTS[19035] = Fluid3D([10821,11553,11644,11221],0); -ELEMENTS[19036] = Fluid3D([11644,10821,11221,10849],0); -ELEMENTS[19037] = Fluid3D([11644,10821,10849,10989],0); -ELEMENTS[19038] = Fluid3D([11644,10821,10989,11455],0); -ELEMENTS[19039] = Fluid3D([11553,11644,11221,11660],0); -ELEMENTS[19040] = Fluid3D([11644,11221,11660,10849],0); -ELEMENTS[19041] = Fluid3D([11221,11553,11660,11001],0); -ELEMENTS[19042] = Fluid3D([11660,11221,11001,10126],0); -ELEMENTS[19043] = Fluid3D([11221,11660,10849,10126],0); -ELEMENTS[19044] = Fluid3D([10849,11644,10989,11157],0); -ELEMENTS[19045] = Fluid3D([10989,10849,11157,10265],0); -ELEMENTS[19046] = Fluid3D([10849,11644,11157,11143],0); -ELEMENTS[19047] = Fluid3D([11157,10849,11143,10126],0); -ELEMENTS[19048] = Fluid3D([10849,11157,10265,10126],0); -ELEMENTS[19049] = Fluid3D([11157,10989,10265,11195],0); -ELEMENTS[19050] = Fluid3D([10989,10265,11195,10354],0); -ELEMENTS[19051] = Fluid3D([10989,10849,10265,10821],0); -ELEMENTS[19052] = Fluid3D([11157,10989,11195,11685],0); -ELEMENTS[19053] = Fluid3D([10989,11195,11685,10354],0); -ELEMENTS[19054] = Fluid3D([10265,10989,10821,10455],0); -ELEMENTS[19055] = Fluid3D([10265,10989,10455,10354],0); -ELEMENTS[19056] = Fluid3D([11644,10989,11157,11685],0); -ELEMENTS[19057] = Fluid3D([11644,10989,11685,11455],0); -ELEMENTS[19058] = Fluid3D([11221,11553,11001,10821],0); -ELEMENTS[19059] = Fluid3D([10989,10821,10455,11455],0); -ELEMENTS[19060] = Fluid3D([10821,11221,10849,11001],0); -ELEMENTS[19061] = Fluid3D([10849,11143,10126,11660],0); -ELEMENTS[19062] = Fluid3D([10821,10904,11553,11001],0); -ELEMENTS[19063] = Fluid3D([10745,10904,10182,9734],0); -ELEMENTS[19064] = Fluid3D([11691,10745,11455,11579],0); -ELEMENTS[19065] = Fluid3D([11376,11579,12321,11742],0); -ELEMENTS[19066] = Fluid3D([10955,11691,10904,11618],0); -ELEMENTS[19067] = Fluid3D([13313,13175,12465,12836],0); -ELEMENTS[19068] = Fluid3D([12465,13313,12836,12384],0); -ELEMENTS[19069] = Fluid3D([13175,12465,12836,12323],0); -ELEMENTS[19070] = Fluid3D([13313,13175,12836,13740],0); -ELEMENTS[19071] = Fluid3D([12836,13313,13740,13410],0); -ELEMENTS[19072] = Fluid3D([13313,13740,13410,14427],0); -ELEMENTS[19073] = Fluid3D([13313,13175,13740,13940],0); -ELEMENTS[19074] = Fluid3D([13740,12836,13410,13445],0); -ELEMENTS[19075] = Fluid3D([13175,12836,13740,13445],0); -ELEMENTS[19076] = Fluid3D([12836,13313,13410,12384],0); -ELEMENTS[19077] = Fluid3D([10274,9286,9400,9907],0); -ELEMENTS[19078] = Fluid3D([10592,10023,10965,10042],0); -ELEMENTS[19079] = Fluid3D([11934,12650,11524,12035],0); -ELEMENTS[19080] = Fluid3D([11524,11934,12035,11116],0); -ELEMENTS[19081] = Fluid3D([11934,12035,11116,11881],0); -ELEMENTS[19082] = Fluid3D([11934,12035,11881,12733],0); -ELEMENTS[19083] = Fluid3D([12035,11116,11881,11438],0); -ELEMENTS[19084] = Fluid3D([12035,11881,12733,13046],0); -ELEMENTS[19085] = Fluid3D([11934,12650,12035,12733],0); -ELEMENTS[19086] = Fluid3D([11116,11881,11438,10941],0); -ELEMENTS[19087] = Fluid3D([11116,11881,10941,11210],0); -ELEMENTS[19088] = Fluid3D([10941,11116,11210,10254],0); -ELEMENTS[19089] = Fluid3D([11438,11116,10941,10421],0); -ELEMENTS[19090] = Fluid3D([11438,11116,10421,10984],0); -ELEMENTS[19091] = Fluid3D([11116,10421,10984,10298],0); -ELEMENTS[19092] = Fluid3D([11116,10421,10298,10254],0); -ELEMENTS[19093] = Fluid3D([11881,11438,10941,11728],0); -ELEMENTS[19094] = Fluid3D([11881,11438,11728,12438],0); -ELEMENTS[19095] = Fluid3D([11881,11438,12438,12035],0); -ELEMENTS[19096] = Fluid3D([11438,10941,11728,10857],0); -ELEMENTS[19097] = Fluid3D([11438,10941,10857,10421],0); -ELEMENTS[19098] = Fluid3D([10941,11728,10857,10962],0); -ELEMENTS[19099] = Fluid3D([10857,10941,10962,9973],0); -ELEMENTS[19100] = Fluid3D([10857,10941,9973,10421],0); -ELEMENTS[19101] = Fluid3D([10941,11728,10962,11523],0); -ELEMENTS[19102] = Fluid3D([11728,10962,11523,11730],0); -ELEMENTS[19103] = Fluid3D([11728,10962,11730,11350],0); -ELEMENTS[19104] = Fluid3D([11728,10962,11350,10857],0); -ELEMENTS[19105] = Fluid3D([10941,11728,11523,11881],0); -ELEMENTS[19106] = Fluid3D([10962,10857,9973,10261],0); -ELEMENTS[19107] = Fluid3D([10857,9973,10261,9866],0); -ELEMENTS[19108] = Fluid3D([10857,9973,9866,10421],0); -ELEMENTS[19109] = Fluid3D([10962,10857,10261,11350],0); -ELEMENTS[19110] = Fluid3D([10261,10857,9866,10600],0); -ELEMENTS[19111] = Fluid3D([10261,10857,10600,11350],0); -ELEMENTS[19112] = Fluid3D([9866,10261,10600,9669],0); -ELEMENTS[19113] = Fluid3D([9866,10261,9669,9260],0); -ELEMENTS[19114] = Fluid3D([9866,10261,9260,9973],0); -ELEMENTS[19115] = Fluid3D([10857,9866,10600,10604],0); -ELEMENTS[19116] = Fluid3D([10857,9866,10604,10421],0); -ELEMENTS[19117] = Fluid3D([10600,10857,10604,11656],0); -ELEMENTS[19118] = Fluid3D([10600,10857,11656,11350],0); -ELEMENTS[19119] = Fluid3D([10857,10604,11656,11438],0); -ELEMENTS[19120] = Fluid3D([11438,11116,10984,12035],0); -ELEMENTS[19121] = Fluid3D([10261,10600,9669,10511],0); -ELEMENTS[19122] = Fluid3D([9669,10261,10511,9531],0); -ELEMENTS[19123] = Fluid3D([10261,10600,10511,11350],0); -ELEMENTS[19124] = Fluid3D([10600,9669,10511,10242],0); -ELEMENTS[19125] = Fluid3D([10600,9669,10242,9858],0); -ELEMENTS[19126] = Fluid3D([10600,9669,9858,9866],0); -ELEMENTS[19127] = Fluid3D([9669,10511,10242,9811],0); -ELEMENTS[19128] = Fluid3D([9669,10511,9811,9531],0); -ELEMENTS[19129] = Fluid3D([10511,10242,9811,10637],0); -ELEMENTS[19130] = Fluid3D([10511,10242,10637,11233],0); -ELEMENTS[19131] = Fluid3D([10242,9811,10637,9894],0); -ELEMENTS[19132] = Fluid3D([10242,9811,9894,9223],0); -ELEMENTS[19133] = Fluid3D([10242,9811,9223,9669],0); -ELEMENTS[19134] = Fluid3D([10511,10242,11233,10600],0); -ELEMENTS[19135] = Fluid3D([9669,10261,9531,9260],0); -ELEMENTS[19136] = Fluid3D([10941,11116,10254,10421],0); -ELEMENTS[19137] = Fluid3D([10261,10511,9531,10655],0); -ELEMENTS[19138] = Fluid3D([10261,10511,10655,11350],0); -ELEMENTS[19139] = Fluid3D([10511,9531,10655,10302],0); -ELEMENTS[19140] = Fluid3D([10511,9531,10302,9811],0); -ELEMENTS[19141] = Fluid3D([10655,10511,10302,11166],0); -ELEMENTS[19142] = Fluid3D([10655,10511,11166,11350],0); -ELEMENTS[19143] = Fluid3D([10511,10302,11166,10637],0); -ELEMENTS[19144] = Fluid3D([9531,10655,10302,10303],0); -ELEMENTS[19145] = Fluid3D([9531,10261,10655,9785],0); -ELEMENTS[19146] = Fluid3D([10261,10655,9785,10962],0); -ELEMENTS[19147] = Fluid3D([9531,10261,9785,9260],0); -ELEMENTS[19148] = Fluid3D([10655,9531,9785,10303],0); -ELEMENTS[19149] = Fluid3D([9973,10962,10261,9785],0); -ELEMENTS[19150] = Fluid3D([11881,10941,11210,11523],0); -ELEMENTS[19151] = Fluid3D([9811,10511,10637,10302],0); -ELEMENTS[19152] = Fluid3D([11116,11881,11210,11934],0); -ELEMENTS[19153] = Fluid3D([9669,9866,9260,8965],0); -ELEMENTS[19154] = Fluid3D([9260,9669,8965,8756],0); -ELEMENTS[19155] = Fluid3D([9669,9866,8965,9858],0); -ELEMENTS[19156] = Fluid3D([9866,9260,8965,9069],0); -ELEMENTS[19157] = Fluid3D([9866,9260,9069,9973],0); -ELEMENTS[19158] = Fluid3D([8965,9260,8756,8342],0); -ELEMENTS[19159] = Fluid3D([8756,8965,8342,8483],0); -ELEMENTS[19160] = Fluid3D([8965,9260,8342,9069],0); -ELEMENTS[19161] = Fluid3D([9260,8756,8342,8635],0); -ELEMENTS[19162] = Fluid3D([9260,9669,8756,9531],0); -ELEMENTS[19163] = Fluid3D([9669,8965,8756,9223],0); -ELEMENTS[19164] = Fluid3D([11210,10941,10254,10542],0); -ELEMENTS[19165] = Fluid3D([11210,10941,10542,11523],0); -ELEMENTS[19166] = Fluid3D([10254,11210,10542,10207],0); -ELEMENTS[19167] = Fluid3D([10941,10254,10542,9973],0); -ELEMENTS[19168] = Fluid3D([8965,9866,9069,9313],0); -ELEMENTS[19169] = Fluid3D([9866,9069,9313,10421],0); -ELEMENTS[19170] = Fluid3D([8965,9866,9313,9858],0); -ELEMENTS[19171] = Fluid3D([9069,8965,9313,8396],0); -ELEMENTS[19172] = Fluid3D([8965,9313,8396,8712],0); -ELEMENTS[19173] = Fluid3D([9313,8396,8712,8654],0); -ELEMENTS[19174] = Fluid3D([9313,8396,8654,8874],0); -ELEMENTS[19175] = Fluid3D([8396,8712,8654,7870],0); -ELEMENTS[19176] = Fluid3D([8396,8654,8874,7984],0); -ELEMENTS[19177] = Fluid3D([8396,8654,7984,7870],0); -ELEMENTS[19178] = Fluid3D([9069,8965,8396,8342],0); -ELEMENTS[19179] = Fluid3D([9313,8396,8874,9069],0); -ELEMENTS[19180] = Fluid3D([8712,8654,7870,8450],0); -ELEMENTS[19181] = Fluid3D([8712,8654,8450,9335],0); -ELEMENTS[19182] = Fluid3D([8654,7870,8450,7960],0); -ELEMENTS[19183] = Fluid3D([8654,7870,7960,7984],0); -ELEMENTS[19184] = Fluid3D([7870,8712,8450,7641],0); -ELEMENTS[19185] = Fluid3D([8654,8450,9335,8950],0); -ELEMENTS[19186] = Fluid3D([8654,8450,8950,7960],0); -ELEMENTS[19187] = Fluid3D([9335,8654,8950,9542],0); -ELEMENTS[19188] = Fluid3D([8450,9335,8950,9357],0); -ELEMENTS[19189] = Fluid3D([8450,9335,9357,8727],0); -ELEMENTS[19190] = Fluid3D([9357,8450,8727,8282],0); -ELEMENTS[19191] = Fluid3D([8727,9357,8282,9067],0); -ELEMENTS[19192] = Fluid3D([8450,8727,8282,7717],0); -ELEMENTS[19193] = Fluid3D([8450,8727,7717,8197],0); -ELEMENTS[19194] = Fluid3D([8450,8727,8197,9081],0); -ELEMENTS[19195] = Fluid3D([8450,8727,9081,9335],0); -ELEMENTS[19196] = Fluid3D([9081,8450,9335,8712],0); -ELEMENTS[19197] = Fluid3D([9335,9081,8712,9858],0); -ELEMENTS[19198] = Fluid3D([9081,8450,8712,8197],0); -ELEMENTS[19199] = Fluid3D([8712,9081,8197,8890],0); -ELEMENTS[19200] = Fluid3D([8712,9081,8890,9858],0); -ELEMENTS[19201] = Fluid3D([8197,8712,8890,8483],0); -ELEMENTS[19202] = Fluid3D([8712,8890,8483,8965],0); -ELEMENTS[19203] = Fluid3D([8890,8197,8483,7994],0); -ELEMENTS[19204] = Fluid3D([8483,8890,7994,8708],0); -ELEMENTS[19205] = Fluid3D([8727,8282,7717,8048],0); -ELEMENTS[19206] = Fluid3D([8727,7717,8197,7733],0); -ELEMENTS[19207] = Fluid3D([7717,8197,7733,7641],0); -ELEMENTS[19208] = Fluid3D([8727,8197,9081,8829],0); -ELEMENTS[19209] = Fluid3D([9081,8197,8890,8829],0); -ELEMENTS[19210] = Fluid3D([8727,8197,8829,7733],0); -ELEMENTS[19211] = Fluid3D([9357,8450,8282,8950],0); -ELEMENTS[19212] = Fluid3D([8450,8712,8197,7641],0); -ELEMENTS[19213] = Fluid3D([7717,8450,8197,7641],0); -ELEMENTS[19214] = Fluid3D([9081,8727,8829,9493],0); -ELEMENTS[19215] = Fluid3D([9081,8727,9493,9335],0); -ELEMENTS[19216] = Fluid3D([8727,8829,9493,9638],0); -ELEMENTS[19217] = Fluid3D([8282,8450,7717,7960],0); -ELEMENTS[19218] = Fluid3D([8829,9081,9493,9681],0); -ELEMENTS[19219] = Fluid3D([9081,9493,9681,10241],0); -ELEMENTS[19220] = Fluid3D([9081,9493,10241,9335],0); -ELEMENTS[19221] = Fluid3D([10241,9081,9335,9858],0); -ELEMENTS[19222] = Fluid3D([9335,8654,9542,9313],0); -ELEMENTS[19223] = Fluid3D([8396,8712,7870,7641],0); -ELEMENTS[19224] = Fluid3D([8654,8950,9542,8736],0); -ELEMENTS[19225] = Fluid3D([8654,8950,8736,7960],0); -ELEMENTS[19226] = Fluid3D([8950,9542,8736,9482],0); -ELEMENTS[19227] = Fluid3D([9542,8736,9482,9581],0); -ELEMENTS[19228] = Fluid3D([9542,8654,8736,8874],0); -ELEMENTS[19229] = Fluid3D([9542,8736,9581,8874],0); -ELEMENTS[19230] = Fluid3D([8950,9542,9482,10147],0); -ELEMENTS[19231] = Fluid3D([9542,9482,10147,10349],0); -ELEMENTS[19232] = Fluid3D([9482,8950,10147,9353],0); -ELEMENTS[19233] = Fluid3D([9482,8950,9353,8706],0); -ELEMENTS[19234] = Fluid3D([9482,8950,8706,8736],0); -ELEMENTS[19235] = Fluid3D([8950,9542,10147,9335],0); -ELEMENTS[19236] = Fluid3D([9542,9482,10349,9581],0); -ELEMENTS[19237] = Fluid3D([8712,8654,9335,9313],0); -ELEMENTS[19238] = Fluid3D([8654,9313,8874,9542],0); -ELEMENTS[19239] = Fluid3D([8965,9313,8712,9858],0); -ELEMENTS[19240] = Fluid3D([8396,8965,8712,8013],0); -ELEMENTS[19241] = Fluid3D([8965,8712,8013,8483],0); -ELEMENTS[19242] = Fluid3D([8013,8965,8483,8342],0); -ELEMENTS[19243] = Fluid3D([8712,8396,8013,7641],0); -ELEMENTS[19244] = Fluid3D([8396,8965,8013,8342],0); -ELEMENTS[19245] = Fluid3D([7870,8450,7960,7717],0); -ELEMENTS[19246] = Fluid3D([8654,8874,7984,8736],0); -ELEMENTS[19247] = Fluid3D([10421,10984,10298,10193],0); -ELEMENTS[19248] = Fluid3D([10421,10984,10193,10604],0); -ELEMENTS[19249] = Fluid3D([10298,10421,10193,9473],0); -ELEMENTS[19250] = Fluid3D([10298,10421,9473,10254],0); -ELEMENTS[19251] = Fluid3D([10984,10298,10193,10500],0); -ELEMENTS[19252] = Fluid3D([10193,10298,9473,9581],0); -ELEMENTS[19253] = Fluid3D([10298,10193,10500,9581],0); -ELEMENTS[19254] = Fluid3D([10421,10193,9473,9313],0); -ELEMENTS[19255] = Fluid3D([10984,10298,10500,11524],0); -ELEMENTS[19256] = Fluid3D([10193,10984,10500,10349],0); -ELEMENTS[19257] = Fluid3D([11881,11934,12733,12459],0); -ELEMENTS[19258] = Fluid3D([12650,11524,12035,12582],0); -ELEMENTS[19259] = Fluid3D([12035,11524,11116,10984],0); -ELEMENTS[19260] = Fluid3D([10962,11730,11350,11219],0); -ELEMENTS[19261] = Fluid3D([11116,11210,10254,11103],0); -ELEMENTS[19262] = Fluid3D([11524,11934,11116,11103],0); -ELEMENTS[19263] = Fluid3D([11728,11438,10857,11656],0); -ELEMENTS[19264] = Fluid3D([11728,11881,12438,12647],0); -ELEMENTS[19265] = Fluid3D([11881,12438,12647,13046],0); -ELEMENTS[19266] = Fluid3D([12438,11728,12647,12979],0); -ELEMENTS[19267] = Fluid3D([11728,11881,12647,11523],0); -ELEMENTS[19268] = Fluid3D([8829,9081,9681,8890],0); -ELEMENTS[19269] = Fluid3D([10302,10655,11166,10999],0); -ELEMENTS[19270] = Fluid3D([10655,11166,10999,11219],0); -ELEMENTS[19271] = Fluid3D([10999,10655,11219,10303],0); -ELEMENTS[19272] = Fluid3D([10655,11166,11219,11350],0); -ELEMENTS[19273] = Fluid3D([10999,10655,10303,10302],0); -ELEMENTS[19274] = Fluid3D([10655,11219,10303,9785],0); -ELEMENTS[19275] = Fluid3D([11219,10999,10303,11301],0); -ELEMENTS[19276] = Fluid3D([10999,10303,11301,10597],0); -ELEMENTS[19277] = Fluid3D([11219,10999,11301,11902],0); -ELEMENTS[19278] = Fluid3D([11301,10999,10597,11485],0); -ELEMENTS[19279] = Fluid3D([11301,10999,11485,11902],0); -ELEMENTS[19280] = Fluid3D([10999,10303,10597,10302],0); -ELEMENTS[19281] = Fluid3D([11166,10999,11219,11902],0); -ELEMENTS[19282] = Fluid3D([11166,10999,11902,11217],0); -ELEMENTS[19283] = Fluid3D([11902,11166,11217,11861],0); -ELEMENTS[19284] = Fluid3D([11902,11166,11861,11848],0); -ELEMENTS[19285] = Fluid3D([11902,11166,11848,11219],0); -ELEMENTS[19286] = Fluid3D([11166,11861,11848,11233],0); -ELEMENTS[19287] = Fluid3D([11166,11848,11219,11350],0); -ELEMENTS[19288] = Fluid3D([11848,11219,11350,12504],0); -ELEMENTS[19289] = Fluid3D([11166,11848,11350,11233],0); -ELEMENTS[19290] = Fluid3D([11166,10999,11217,10302],0); -ELEMENTS[19291] = Fluid3D([11166,11861,11233,10637],0); -ELEMENTS[19292] = Fluid3D([10421,11438,10984,10604],0); -ELEMENTS[19293] = Fluid3D([11438,11728,12438,11656],0); -ELEMENTS[19294] = Fluid3D([10962,11523,11730,11664],0); -ELEMENTS[19295] = Fluid3D([10984,11116,10298,11524],0); -ELEMENTS[19296] = Fluid3D([10242,10600,9858,10634],0); -ELEMENTS[19297] = Fluid3D([9858,10242,10634,9681],0); -ELEMENTS[19298] = Fluid3D([10242,10600,10634,11233],0); -ELEMENTS[19299] = Fluid3D([10600,9858,10634,10604],0); -ELEMENTS[19300] = Fluid3D([9866,10600,10604,9858],0); -ELEMENTS[19301] = Fluid3D([12268,13160,12730,13334],0); -ELEMENTS[19302] = Fluid3D([10131,10778,9756,10232],0); -ELEMENTS[19303] = Fluid3D([11409,11981,11894,11073],0); -ELEMENTS[19304] = Fluid3D([11894,11409,11073,10778],0); -ELEMENTS[19305] = Fluid3D([11981,11894,11073,11671],0); -ELEMENTS[19306] = Fluid3D([11894,11073,11671,11000],0); -ELEMENTS[19307] = Fluid3D([11409,11981,11073,11064],0); -ELEMENTS[19308] = Fluid3D([12783,13761,13512,13535],0); -ELEMENTS[19309] = Fluid3D([12783,13761,13535,13172],0); -ELEMENTS[19310] = Fluid3D([13512,12783,13535,13040],0); -ELEMENTS[19311] = Fluid3D([13761,13512,13535,14211],0); -ELEMENTS[19312] = Fluid3D([13535,13761,14211,14080],0); -ELEMENTS[19313] = Fluid3D([13761,13512,14211,14231],0); -ELEMENTS[19314] = Fluid3D([13761,13512,14231,13232],0); -ELEMENTS[19315] = Fluid3D([13761,14211,14080,14583],0); -ELEMENTS[19316] = Fluid3D([13761,14211,14583,14231],0); -ELEMENTS[19317] = Fluid3D([14080,13761,14583,14098],0); -ELEMENTS[19318] = Fluid3D([14080,13761,14098,13172],0); -ELEMENTS[19319] = Fluid3D([14583,14080,14098,14748],0); -ELEMENTS[19320] = Fluid3D([14080,14098,14748,14026],0); -ELEMENTS[19321] = Fluid3D([14080,14098,14026,13172],0); -ELEMENTS[19322] = Fluid3D([14583,14080,14748,14840],0); -ELEMENTS[19323] = Fluid3D([14583,14080,14840,14211],0); -ELEMENTS[19324] = Fluid3D([14080,14748,14840,14533],0); -ELEMENTS[19325] = Fluid3D([14080,14748,14533,14026],0); -ELEMENTS[19326] = Fluid3D([14840,14080,14533,14260],0); -ELEMENTS[19327] = Fluid3D([14840,14080,14260,14211],0); -ELEMENTS[19328] = Fluid3D([14748,14583,14840,15296],0); -ELEMENTS[19329] = Fluid3D([14583,14840,15296,15190],0); -ELEMENTS[19330] = Fluid3D([14533,14840,14260,15052],0); -ELEMENTS[19331] = Fluid3D([14840,14260,15052,14427],0); -ELEMENTS[19332] = Fluid3D([14748,14583,15296,14941],0); -ELEMENTS[19333] = Fluid3D([14583,15296,14941,15361],0); -ELEMENTS[19334] = Fluid3D([14748,14583,14941,14098],0); -ELEMENTS[19335] = Fluid3D([14533,14840,15052,15295],0); -ELEMENTS[19336] = Fluid3D([14533,14840,15295,14748],0); -ELEMENTS[19337] = Fluid3D([14840,15052,15295,15460],0); -ELEMENTS[19338] = Fluid3D([13512,14211,14231,14220],0); -ELEMENTS[19339] = Fluid3D([14231,13512,14220,13780],0); -ELEMENTS[19340] = Fluid3D([14211,14231,14220,15190],0); -ELEMENTS[19341] = Fluid3D([13512,14220,13780,13649],0); -ELEMENTS[19342] = Fluid3D([13512,14220,13649,14112],0); -ELEMENTS[19343] = Fluid3D([13512,14220,14112,14211],0); -ELEMENTS[19344] = Fluid3D([14220,14112,14211,15190],0); -ELEMENTS[19345] = Fluid3D([14112,13512,14211,13535],0); -ELEMENTS[19346] = Fluid3D([14220,13780,13649,14242],0); -ELEMENTS[19347] = Fluid3D([14231,13512,13780,13232],0); -ELEMENTS[19348] = Fluid3D([14220,14231,13780,14906],0); -ELEMENTS[19349] = Fluid3D([14098,14748,14026,14499],0); -ELEMENTS[19350] = Fluid3D([14026,14098,14499,13483],0); -ELEMENTS[19351] = Fluid3D([14098,14748,14499,14941],0); -ELEMENTS[19352] = Fluid3D([14499,14026,13483,14128],0); -ELEMENTS[19353] = Fluid3D([14026,13483,14128,13311],0); -ELEMENTS[19354] = Fluid3D([14499,14026,14128,14506],0); -ELEMENTS[19355] = Fluid3D([14748,14026,14499,14506],0); -ELEMENTS[19356] = Fluid3D([14026,14128,14506,13812],0); -ELEMENTS[19357] = Fluid3D([14026,14098,13483,13172],0); -ELEMENTS[19358] = Fluid3D([14098,14499,13483,14177],0); -ELEMENTS[19359] = Fluid3D([14098,14499,14177,14941],0); -ELEMENTS[19360] = Fluid3D([13483,14098,14177,13412],0); -ELEMENTS[19361] = Fluid3D([13483,14098,13412,13172],0); -ELEMENTS[19362] = Fluid3D([14499,13483,14177,14155],0); -ELEMENTS[19363] = Fluid3D([14177,13483,13412,13403],0); -ELEMENTS[19364] = Fluid3D([13483,14177,14155,13403],0); -ELEMENTS[19365] = Fluid3D([14499,13483,14155,14128],0); -ELEMENTS[19366] = Fluid3D([14098,14177,13412,13809],0); -ELEMENTS[19367] = Fluid3D([14177,14499,14155,14859],0); -ELEMENTS[19368] = Fluid3D([14177,14499,14859,14941],0); -ELEMENTS[19369] = Fluid3D([14155,14177,14859,14292],0); -ELEMENTS[19370] = Fluid3D([14155,14177,14292,13403],0); -ELEMENTS[19371] = Fluid3D([14499,14155,14859,14847],0); -ELEMENTS[19372] = Fluid3D([14499,14155,14847,14128],0); -ELEMENTS[19373] = Fluid3D([14859,14155,14292,14712],0); -ELEMENTS[19374] = Fluid3D([14155,14292,14712,13885],0); -ELEMENTS[19375] = Fluid3D([14155,14859,14847,14712],0); -ELEMENTS[19376] = Fluid3D([14292,14712,13885,14448],0); -ELEMENTS[19377] = Fluid3D([14292,14712,14448,15031],0); -ELEMENTS[19378] = Fluid3D([14292,14712,15031,14859],0); -ELEMENTS[19379] = Fluid3D([13885,14292,14448,13688],0); -ELEMENTS[19380] = Fluid3D([13885,14292,13688,13403],0); -ELEMENTS[19381] = Fluid3D([14292,14448,13688,14409],0); -ELEMENTS[19382] = Fluid3D([14292,14448,14409,15031],0); -ELEMENTS[19383] = Fluid3D([14448,13688,14409,14106],0); -ELEMENTS[19384] = Fluid3D([14409,14448,14106,14915],0); -ELEMENTS[19385] = Fluid3D([14409,14448,14915,15031],0); -ELEMENTS[19386] = Fluid3D([14448,13688,14106,13884],0); -ELEMENTS[19387] = Fluid3D([14448,13688,13884,13885],0); -ELEMENTS[19388] = Fluid3D([13688,14106,13884,12980],0); -ELEMENTS[19389] = Fluid3D([14155,14292,13885,13403],0); -ELEMENTS[19390] = Fluid3D([14712,13885,14448,14424],0); -ELEMENTS[19391] = Fluid3D([13885,14448,14424,13884],0); -ELEMENTS[19392] = Fluid3D([14712,13885,14424,14247],0); -ELEMENTS[19393] = Fluid3D([14424,14712,14247,14987],0); -ELEMENTS[19394] = Fluid3D([14424,14712,14987,15141],0); -ELEMENTS[19395] = Fluid3D([14424,14712,15141,14448],0); -ELEMENTS[19396] = Fluid3D([14712,13885,14247,14155],0); -ELEMENTS[19397] = Fluid3D([14247,14424,14987,14423],0); -ELEMENTS[19398] = Fluid3D([14424,14987,14423,15115],0); -ELEMENTS[19399] = Fluid3D([14247,14424,14423,13736],0); -ELEMENTS[19400] = Fluid3D([14424,14423,13736,14142],0); -ELEMENTS[19401] = Fluid3D([14424,14423,14142,15115],0); -ELEMENTS[19402] = Fluid3D([14987,14247,14423,14710],0); -ELEMENTS[19403] = Fluid3D([14247,14423,14710,13883],0); -ELEMENTS[19404] = Fluid3D([14247,14423,13883,13736],0); -ELEMENTS[19405] = Fluid3D([14987,14247,14710,14847],0); -ELEMENTS[19406] = Fluid3D([13885,14424,14247,13736],0); -ELEMENTS[19407] = Fluid3D([14423,13736,14142,13842],0); -ELEMENTS[19408] = Fluid3D([14177,14859,14292,14739],0); -ELEMENTS[19409] = Fluid3D([14177,14859,14739,14941],0); -ELEMENTS[19410] = Fluid3D([14292,14177,14739,13912],0); -ELEMENTS[19411] = Fluid3D([14292,14177,13912,13403],0); -ELEMENTS[19412] = Fluid3D([14859,14292,14739,15031],0); -ELEMENTS[19413] = Fluid3D([14739,14292,13912,14409],0); -ELEMENTS[19414] = Fluid3D([14177,14739,13912,14277],0); -ELEMENTS[19415] = Fluid3D([14177,14739,14277,14941],0); -ELEMENTS[19416] = Fluid3D([14739,13912,14277,14460],0); -ELEMENTS[19417] = Fluid3D([14277,14739,14460,15017],0); -ELEMENTS[19418] = Fluid3D([14277,14739,15017,14941],0); -ELEMENTS[19419] = Fluid3D([14739,13912,14460,14409],0); -ELEMENTS[19420] = Fluid3D([13912,14177,14277,13475],0); -ELEMENTS[19421] = Fluid3D([14277,13912,13475,14460],0); -ELEMENTS[19422] = Fluid3D([14739,14460,15017,15183],0); -ELEMENTS[19423] = Fluid3D([14739,14460,15183,14409],0); -ELEMENTS[19424] = Fluid3D([14460,15017,15183,15063],0); -ELEMENTS[19425] = Fluid3D([15183,14460,15063,14808],0); -ELEMENTS[19426] = Fluid3D([15183,14460,14808,14409],0); -ELEMENTS[19427] = Fluid3D([14460,15017,15063,14513],0); -ELEMENTS[19428] = Fluid3D([15017,15063,14513,15283],0); -ELEMENTS[19429] = Fluid3D([15063,14513,15283,14858],0); -ELEMENTS[19430] = Fluid3D([14460,15017,14513,14277],0); -ELEMENTS[19431] = Fluid3D([15017,15063,15283,15711],0); -ELEMENTS[19432] = Fluid3D([15063,15283,15711,15472],0); -ELEMENTS[19433] = Fluid3D([15063,15283,15472,14858],0); -ELEMENTS[19434] = Fluid3D([15472,15063,14858,14808],0); -ELEMENTS[19435] = Fluid3D([15711,15063,15472,15183],0); -ELEMENTS[19436] = Fluid3D([15017,14739,15183,15441],0); -ELEMENTS[19437] = Fluid3D([15017,14739,15441,14941],0); -ELEMENTS[19438] = Fluid3D([14739,15183,15441,15031],0); -ELEMENTS[19439] = Fluid3D([15183,15017,15441,15711],0); -ELEMENTS[19440] = Fluid3D([15017,15183,15063,15711],0); -ELEMENTS[19441] = Fluid3D([14460,15063,14808,14858],0); -ELEMENTS[19442] = Fluid3D([15296,14748,14941,15390],0); -ELEMENTS[19443] = Fluid3D([14941,15296,15390,15777],0); -ELEMENTS[19444] = Fluid3D([14748,14941,15390,14499],0); -ELEMENTS[19445] = Fluid3D([15296,14748,15390,15295],0); -ELEMENTS[19446] = Fluid3D([13688,14292,14409,13912],0); -ELEMENTS[19447] = Fluid3D([14128,14499,14506,14847],0); -ELEMENTS[19448] = Fluid3D([14859,14499,14847,15390],0); -ELEMENTS[19449] = Fluid3D([14423,14987,14710,15434],0); -ELEMENTS[19450] = Fluid3D([14211,13535,14080,14260],0); -ELEMENTS[19451] = Fluid3D([15052,14533,15295,15090],0); -ELEMENTS[19452] = Fluid3D([14533,15295,15090,14506],0); -ELEMENTS[19453] = Fluid3D([15295,15052,15090,15609],0); -ELEMENTS[19454] = Fluid3D([15295,15052,15609,15883],0); -ELEMENTS[19455] = Fluid3D([15090,15295,15609,15716],0); -ELEMENTS[19456] = Fluid3D([15295,15609,15716,15883],0); -ELEMENTS[19457] = Fluid3D([15052,14533,15090,14501],0); -ELEMENTS[19458] = Fluid3D([14533,15090,14501,13812],0); -ELEMENTS[19459] = Fluid3D([15090,15052,14501,15094],0); -ELEMENTS[19460] = Fluid3D([15090,15052,15094,15609],0); -ELEMENTS[19461] = Fluid3D([15052,14533,14501,14260],0); -ELEMENTS[19462] = Fluid3D([15052,14501,15094,14834],0); -ELEMENTS[19463] = Fluid3D([15090,15295,15716,15035],0); -ELEMENTS[19464] = Fluid3D([15090,15295,15035,14506],0); -ELEMENTS[19465] = Fluid3D([15295,15716,15035,15523],0); -ELEMENTS[19466] = Fluid3D([15295,15716,15523,16269],0); -ELEMENTS[19467] = Fluid3D([15035,15295,15523,15390],0); -ELEMENTS[19468] = Fluid3D([15295,15523,15390,16026],0); -ELEMENTS[19469] = Fluid3D([15716,15090,15035,15321],0); -ELEMENTS[19470] = Fluid3D([15090,15035,15321,14854],0); -ELEMENTS[19471] = Fluid3D([15716,15090,15321,15587],0); -ELEMENTS[19472] = Fluid3D([15716,15090,15587,15609],0); -ELEMENTS[19473] = Fluid3D([15090,15321,15587,14854],0); -ELEMENTS[19474] = Fluid3D([15035,15716,15321,15523],0); -ELEMENTS[19475] = Fluid3D([14501,15090,15094,14715],0); -ELEMENTS[19476] = Fluid3D([14501,15090,14715,13812],0); -ELEMENTS[19477] = Fluid3D([15090,15094,14715,15587],0); -ELEMENTS[19478] = Fluid3D([15094,14501,14715,14439],0); -ELEMENTS[19479] = Fluid3D([15094,14501,14439,14834],0); -ELEMENTS[19480] = Fluid3D([14715,15094,14439,15182],0); -ELEMENTS[19481] = Fluid3D([15321,15716,15587,15927],0); -ELEMENTS[19482] = Fluid3D([14501,14715,14439,13445],0); -ELEMENTS[19483] = Fluid3D([14712,14448,15031,15141],0); -ELEMENTS[19484] = Fluid3D([14840,14748,15296,15295],0); -ELEMENTS[19485] = Fluid3D([14712,14247,14987,14847],0); -ELEMENTS[19486] = Fluid3D([14987,14424,15141,15115],0); -ELEMENTS[19487] = Fluid3D([13535,13761,14080,13172],0); -ELEMENTS[19488] = Fluid3D([14080,14533,14260,13410],0); -ELEMENTS[19489] = Fluid3D([14260,14080,13410,13535],0); -ELEMENTS[19490] = Fluid3D([14080,13410,13535,13172],0); -ELEMENTS[19491] = Fluid3D([13410,14260,13535,14427],0); -ELEMENTS[19492] = Fluid3D([14106,14409,14915,14588],0); -ELEMENTS[19493] = Fluid3D([14409,14915,14588,15095],0); -ELEMENTS[19494] = Fluid3D([14106,14409,14588,13598],0); -ELEMENTS[19495] = Fluid3D([14915,14588,15095,15304],0); -ELEMENTS[19496] = Fluid3D([15095,14915,15304,15880],0); -ELEMENTS[19497] = Fluid3D([14915,14106,14588,14678],0); -ELEMENTS[19498] = Fluid3D([14915,14588,15304,14678],0); -ELEMENTS[19499] = Fluid3D([14106,14588,14678,13598],0); -ELEMENTS[19500] = Fluid3D([14588,15095,15304,14711],0); -ELEMENTS[19501] = Fluid3D([14915,14106,14678,14600],0); -ELEMENTS[19502] = Fluid3D([14106,14678,14600,13959],0); -ELEMENTS[19503] = Fluid3D([14678,14600,13959,14757],0); -ELEMENTS[19504] = Fluid3D([14678,14600,14757,15259],0); -ELEMENTS[19505] = Fluid3D([14678,14600,15259,14915],0); -ELEMENTS[19506] = Fluid3D([14915,14106,14600,14448],0); -ELEMENTS[19507] = Fluid3D([14600,14757,15259,15110],0); -ELEMENTS[19508] = Fluid3D([14600,14757,15110,14452],0); -ELEMENTS[19509] = Fluid3D([14600,14757,14452,13959],0); -ELEMENTS[19510] = Fluid3D([14757,15110,14452,15072],0); -ELEMENTS[19511] = Fluid3D([14757,15259,15110,15359],0); -ELEMENTS[19512] = Fluid3D([15110,14757,15359,15072],0); -ELEMENTS[19513] = Fluid3D([14757,15259,15359,15047],0); -ELEMENTS[19514] = Fluid3D([15259,15359,15047,15736],0); -ELEMENTS[19515] = Fluid3D([15047,15259,15736,15304],0); -ELEMENTS[19516] = Fluid3D([15259,15110,15359,15737],0); -ELEMENTS[19517] = Fluid3D([15259,15110,15737,15704],0); -ELEMENTS[19518] = Fluid3D([15737,15259,15704,15736],0); -ELEMENTS[19519] = Fluid3D([15110,15359,15737,15568],0); -ELEMENTS[19520] = Fluid3D([15359,15737,15568,16024],0); -ELEMENTS[19521] = Fluid3D([15359,15737,16024,15736],0); -ELEMENTS[19522] = Fluid3D([15110,15359,15568,15072],0); -ELEMENTS[19523] = Fluid3D([14757,15259,15047,14678],0); -ELEMENTS[19524] = Fluid3D([15259,15359,15736,15737],0); -ELEMENTS[19525] = Fluid3D([15568,15359,16024,15541],0); -ELEMENTS[19526] = Fluid3D([14106,14678,13959,13530],0); -ELEMENTS[19527] = Fluid3D([15110,14600,14452,14654],0); -ELEMENTS[19528] = Fluid3D([14600,14452,14654,13884],0); -ELEMENTS[19529] = Fluid3D([15110,14600,14654,15141],0); -ELEMENTS[19530] = Fluid3D([14452,15110,14654,14802],0); -ELEMENTS[19531] = Fluid3D([15110,14654,14802,15715],0); -ELEMENTS[19532] = Fluid3D([14654,14452,14802,14142],0); -ELEMENTS[19533] = Fluid3D([14452,15110,14802,14626],0); -ELEMENTS[19534] = Fluid3D([14802,14452,14626,14213],0); -ELEMENTS[19535] = Fluid3D([14452,14626,14213,14000],0); -ELEMENTS[19536] = Fluid3D([14626,14213,14000,14311],0); -ELEMENTS[19537] = Fluid3D([14213,14000,14311,13845],0); -ELEMENTS[19538] = Fluid3D([14213,14452,14000,13667],0); -ELEMENTS[19539] = Fluid3D([14626,14802,14213,14311],0); -ELEMENTS[19540] = Fluid3D([14802,14452,14213,13667],0); -ELEMENTS[19541] = Fluid3D([14000,14311,13845,13404],0); -ELEMENTS[19542] = Fluid3D([14000,14311,13404,14025],0); -ELEMENTS[19543] = Fluid3D([13404,14000,14025,13766],0); -ELEMENTS[19544] = Fluid3D([13404,14000,13766,12826],0); -ELEMENTS[19545] = Fluid3D([14000,14311,14025,15072],0); -ELEMENTS[19546] = Fluid3D([14025,13404,13766,12767],0); -ELEMENTS[19547] = Fluid3D([14311,13404,14025,13953],0); -ELEMENTS[19548] = Fluid3D([14311,13404,13953,13845],0); -ELEMENTS[19549] = Fluid3D([14000,14025,13766,14355],0); -ELEMENTS[19550] = Fluid3D([14000,14626,14311,15072],0); -ELEMENTS[19551] = Fluid3D([14213,14000,13845,13667],0); -ELEMENTS[19552] = Fluid3D([13404,14025,13953,14097],0); -ELEMENTS[19553] = Fluid3D([14311,14213,13845,14802],0); -ELEMENTS[19554] = Fluid3D([14025,14311,13953,14097],0); -ELEMENTS[19555] = Fluid3D([13845,14213,13667,14802],0); -ELEMENTS[19556] = Fluid3D([13953,14311,13845,13917],0); -ELEMENTS[19557] = Fluid3D([15110,14802,14626,15421],0); -ELEMENTS[19558] = Fluid3D([14802,14626,15421,14908],0); -ELEMENTS[19559] = Fluid3D([14626,15421,14908,15072],0); -ELEMENTS[19560] = Fluid3D([14908,14626,15072,14311],0); -ELEMENTS[19561] = Fluid3D([14626,15421,15072,15110],0); -ELEMENTS[19562] = Fluid3D([14802,14626,14908,14311],0); -ELEMENTS[19563] = Fluid3D([15110,14802,15421,15715],0); -ELEMENTS[19564] = Fluid3D([14452,15110,14626,15072],0); -ELEMENTS[19565] = Fluid3D([15737,15110,15568,15715],0); -ELEMENTS[19566] = Fluid3D([15259,14600,15110,15317],0); -ELEMENTS[19567] = Fluid3D([15259,14600,15317,14915],0); -ELEMENTS[19568] = Fluid3D([14600,15110,15317,15141],0); -ELEMENTS[19569] = Fluid3D([15110,15259,15317,15704],0); -ELEMENTS[19570] = Fluid3D([15259,15317,15704,14915],0); -ELEMENTS[19571] = Fluid3D([15359,14757,15047,14355],0); -ELEMENTS[19572] = Fluid3D([14757,15047,14355,14678],0); -ELEMENTS[19573] = Fluid3D([14409,14915,15095,15031],0); -ELEMENTS[19574] = Fluid3D([14600,14106,13959,13884],0); -ELEMENTS[19575] = Fluid3D([14588,14409,15095,14808],0); -ELEMENTS[19576] = Fluid3D([13959,14678,14757,14355],0); -ELEMENTS[19577] = Fluid3D([14757,13959,14355,14452],0); -ELEMENTS[19578] = Fluid3D([15359,15047,15736,15668],0); -ELEMENTS[19579] = Fluid3D([15359,15047,15668,15062],0); -ELEMENTS[19580] = Fluid3D([15736,15359,15668,16024],0); -ELEMENTS[19581] = Fluid3D([15047,15736,15668,15537],0); -ELEMENTS[19582] = Fluid3D([15668,15047,15537,15062],0); -ELEMENTS[19583] = Fluid3D([15737,15568,16024,16327],0); -ELEMENTS[19584] = Fluid3D([13761,14583,14098,13809],0); -ELEMENTS[19585] = Fluid3D([13483,13412,13403,12448],0); -ELEMENTS[19586] = Fluid3D([13412,14177,13403,13475],0); -ELEMENTS[19587] = Fluid3D([14106,14448,13884,14600],0); -ELEMENTS[19588] = Fluid3D([13780,13512,13649,13041],0); -ELEMENTS[19589] = Fluid3D([13780,13512,13041,13232],0); -ELEMENTS[19590] = Fluid3D([13512,13649,13041,13040],0); -ELEMENTS[19591] = Fluid3D([13512,13649,13040,14112],0); -ELEMENTS[19592] = Fluid3D([13040,13512,14112,13535],0); -ELEMENTS[19593] = Fluid3D([13649,13040,14112,13707],0); -ELEMENTS[19594] = Fluid3D([13649,13780,13041,13138],0); -ELEMENTS[19595] = Fluid3D([13688,14409,14106,13598],0); -ELEMENTS[19596] = Fluid3D([13736,14424,14142,13884],0); -ELEMENTS[19597] = Fluid3D([15063,15183,14808,15472],0); -ELEMENTS[19598] = Fluid3D([14712,14987,15141,15428],0); -ELEMENTS[19599] = Fluid3D([14712,14987,15428,14847],0); -ELEMENTS[19600] = Fluid3D([15141,14712,15428,15031],0); -ELEMENTS[19601] = Fluid3D([14987,15141,15428,15686],0); -ELEMENTS[19602] = Fluid3D([14710,14247,13883,14095],0); -ELEMENTS[19603] = Fluid3D([14247,13883,14095,13449],0); -ELEMENTS[19604] = Fluid3D([13883,14095,13449,13468],0); -ELEMENTS[19605] = Fluid3D([13883,14710,14095,14760],0); -ELEMENTS[19606] = Fluid3D([14710,14247,14095,14847],0); -ELEMENTS[19607] = Fluid3D([14095,13449,13468,13422],0); -ELEMENTS[19608] = Fluid3D([14095,13449,13422,14128],0); -ELEMENTS[19609] = Fluid3D([13422,14095,14128,14009],0); -ELEMENTS[19610] = Fluid3D([14128,13422,14009,13245],0); -ELEMENTS[19611] = Fluid3D([13422,14009,13245,13468],0); -ELEMENTS[19612] = Fluid3D([14095,14128,14009,14773],0); -ELEMENTS[19613] = Fluid3D([14128,14009,14773,14506],0); -ELEMENTS[19614] = Fluid3D([14773,14128,14506,14847],0); -ELEMENTS[19615] = Fluid3D([14095,14128,14773,14847],0); -ELEMENTS[19616] = Fluid3D([13422,14095,14009,13468],0); -ELEMENTS[19617] = Fluid3D([13449,13468,13422,12752],0); -ELEMENTS[19618] = Fluid3D([14128,13422,13245,13311],0); -ELEMENTS[19619] = Fluid3D([14506,14773,14847,15425],0); -ELEMENTS[19620] = Fluid3D([14506,14773,15425,15024],0); -ELEMENTS[19621] = Fluid3D([14506,14773,15024,14009],0); -ELEMENTS[19622] = Fluid3D([14773,15425,15024,15348],0); -ELEMENTS[19623] = Fluid3D([14773,15425,15348,14847],0); -ELEMENTS[19624] = Fluid3D([15024,14773,15348,14724],0); -ELEMENTS[19625] = Fluid3D([15024,14773,14724,14009],0); -ELEMENTS[19626] = Fluid3D([14773,14724,14009,14095],0); -ELEMENTS[19627] = Fluid3D([14773,15348,14724,14710],0); -ELEMENTS[19628] = Fluid3D([15348,15024,14724,15424],0); -ELEMENTS[19629] = Fluid3D([15425,15024,15348,15877],0); -ELEMENTS[19630] = Fluid3D([15348,15024,15424,15877],0); -ELEMENTS[19631] = Fluid3D([14724,15348,15424,15291],0); -ELEMENTS[19632] = Fluid3D([15424,14724,15291,15163],0); -ELEMENTS[19633] = Fluid3D([15348,15425,15877,15855],0); -ELEMENTS[19634] = Fluid3D([15348,15425,15855,15274],0); -ELEMENTS[19635] = Fluid3D([15877,15348,15855,15783],0); -ELEMENTS[19636] = Fluid3D([15855,15348,15274,15629],0); -ELEMENTS[19637] = Fluid3D([15877,15348,15783,15424],0); -ELEMENTS[19638] = Fluid3D([15348,15274,15629,14710],0); -ELEMENTS[19639] = Fluid3D([15425,15877,15855,15985],0); -ELEMENTS[19640] = Fluid3D([15855,15425,15985,15719],0); -ELEMENTS[19641] = Fluid3D([15855,15425,15719,15274],0); -ELEMENTS[19642] = Fluid3D([15855,15348,15629,15783],0); -ELEMENTS[19643] = Fluid3D([15348,15425,15274,14847],0); -ELEMENTS[19644] = Fluid3D([15425,15274,14847,15719],0); -ELEMENTS[19645] = Fluid3D([15024,14724,15424,14933],0); -ELEMENTS[19646] = Fluid3D([15024,14724,14933,14009],0); -ELEMENTS[19647] = Fluid3D([14724,15424,14933,15163],0); -ELEMENTS[19648] = Fluid3D([15424,15024,14933,15877],0); -ELEMENTS[19649] = Fluid3D([14724,15348,15291,14760],0); -ELEMENTS[19650] = Fluid3D([15425,15877,15985,15523],0); -ELEMENTS[19651] = Fluid3D([15985,15425,15523,15719],0); -ELEMENTS[19652] = Fluid3D([15348,15424,15291,15783],0); -ELEMENTS[19653] = Fluid3D([15425,15024,15877,15523],0); -ELEMENTS[19654] = Fluid3D([15985,15855,15719,16356],0); -ELEMENTS[19655] = Fluid3D([15855,15719,16356,15957],0); -ELEMENTS[19656] = Fluid3D([15855,15719,15957,15274],0); -ELEMENTS[19657] = Fluid3D([15985,15855,16356,16389],0); -ELEMENTS[19658] = Fluid3D([15985,15855,16389,15877],0); -ELEMENTS[19659] = Fluid3D([15855,16356,16389,16303],0); -ELEMENTS[19660] = Fluid3D([15855,16356,16303,15957],0); -ELEMENTS[19661] = Fluid3D([16389,15855,16303,15783],0); -ELEMENTS[19662] = Fluid3D([15719,15985,16356,16092],0); -ELEMENTS[19663] = Fluid3D([16356,15719,16092,16113],0); -ELEMENTS[19664] = Fluid3D([16356,15719,16113,15957],0); -ELEMENTS[19665] = Fluid3D([15985,16356,16092,16391],0); -ELEMENTS[19666] = Fluid3D([16092,15985,16391,16026],0); -ELEMENTS[19667] = Fluid3D([15719,15985,16092,15523],0); -ELEMENTS[19668] = Fluid3D([15855,15877,15783,16389],0); -ELEMENTS[19669] = Fluid3D([15719,16092,16113,15705],0); -ELEMENTS[19670] = Fluid3D([16113,15719,15705,15428],0); -ELEMENTS[19671] = Fluid3D([15719,16092,15705,15390],0); -ELEMENTS[19672] = Fluid3D([16092,16113,15705,16334],0); -ELEMENTS[19673] = Fluid3D([13449,13468,12752,12906],0); -ELEMENTS[19674] = Fluid3D([13468,12752,12906,12418],0); -ELEMENTS[19675] = Fluid3D([12906,13468,12418,13234],0); -ELEMENTS[19676] = Fluid3D([12752,13449,12906,12771],0); -ELEMENTS[19677] = Fluid3D([12906,12752,12771,11973],0); -ELEMENTS[19678] = Fluid3D([13449,13468,12906,13883],0); -ELEMENTS[19679] = Fluid3D([12906,13468,13234,13883],0); -ELEMENTS[19680] = Fluid3D([12906,12752,11973,12418],0); -ELEMENTS[19681] = Fluid3D([12752,13449,12771,13038],0); -ELEMENTS[19682] = Fluid3D([12752,13449,13038,13422],0); -ELEMENTS[19683] = Fluid3D([13449,12771,13038,13306],0); -ELEMENTS[19684] = Fluid3D([13449,12771,13306,13736],0); -ELEMENTS[19685] = Fluid3D([12771,12752,13038,12000],0); -ELEMENTS[19686] = Fluid3D([12752,13038,12000,12583],0); -ELEMENTS[19687] = Fluid3D([13038,12000,12583,12448],0); -ELEMENTS[19688] = Fluid3D([12771,12752,12000,11973],0); -ELEMENTS[19689] = Fluid3D([12752,13038,12583,13422],0); -ELEMENTS[19690] = Fluid3D([13038,13449,13306,14155],0); -ELEMENTS[19691] = Fluid3D([13468,12752,12418,12855],0); -ELEMENTS[19692] = Fluid3D([12752,12418,12855,11928],0); -ELEMENTS[19693] = Fluid3D([12752,12418,11928,11973],0); -ELEMENTS[19694] = Fluid3D([12418,13468,12855,13515],0); -ELEMENTS[19695] = Fluid3D([13468,12752,12855,13422],0); -ELEMENTS[19696] = Fluid3D([13038,12771,12000,12372],0); -ELEMENTS[19697] = Fluid3D([12000,13038,12372,12448],0); -ELEMENTS[19698] = Fluid3D([13038,12771,12372,13306],0); -ELEMENTS[19699] = Fluid3D([12771,12000,12372,11696],0); -ELEMENTS[19700] = Fluid3D([12000,12372,11696,11415],0); -ELEMENTS[19701] = Fluid3D([12771,12000,11696,11973],0); -ELEMENTS[19702] = Fluid3D([12372,11696,11415,11687],0); -ELEMENTS[19703] = Fluid3D([12372,11696,11687,12303],0); -ELEMENTS[19704] = Fluid3D([12000,12372,11415,12448],0); -ELEMENTS[19705] = Fluid3D([11415,12372,11687,11614],0); -ELEMENTS[19706] = Fluid3D([12372,11696,12303,12771],0); -ELEMENTS[19707] = Fluid3D([11696,11415,11687,10790],0); -ELEMENTS[19708] = Fluid3D([11696,11415,10790,10937],0); -ELEMENTS[19709] = Fluid3D([10790,11696,10937,10882],0); -ELEMENTS[19710] = Fluid3D([10790,11696,10882,11424],0); -ELEMENTS[19711] = Fluid3D([10790,11696,11424,11687],0); -ELEMENTS[19712] = Fluid3D([11415,11687,10790,10401],0); -ELEMENTS[19713] = Fluid3D([11696,11415,10937,12000],0); -ELEMENTS[19714] = Fluid3D([11696,10937,10882,11973],0); -ELEMENTS[19715] = Fluid3D([12418,12906,13234,12366],0); -ELEMENTS[19716] = Fluid3D([12418,12906,12366,11973],0); -ELEMENTS[19717] = Fluid3D([13234,12418,12366,12525],0); -ELEMENTS[19718] = Fluid3D([13234,12418,12525,13016],0); -ELEMENTS[19719] = Fluid3D([12366,13234,12525,12907],0); -ELEMENTS[19720] = Fluid3D([13234,12525,12907,13794],0); -ELEMENTS[19721] = Fluid3D([12906,13234,12366,13136],0); -ELEMENTS[19722] = Fluid3D([12366,13234,12907,13136],0); -ELEMENTS[19723] = Fluid3D([12418,12366,12525,11292],0); -ELEMENTS[19724] = Fluid3D([12525,12366,12907,12215],0); -ELEMENTS[19725] = Fluid3D([12525,12366,12215,11292],0); -ELEMENTS[19726] = Fluid3D([12907,12525,12215,13146],0); -ELEMENTS[19727] = Fluid3D([12366,12907,12215,12288],0); -ELEMENTS[19728] = Fluid3D([12366,12907,12288,13136],0); -ELEMENTS[19729] = Fluid3D([12907,12215,12288,12643],0); -ELEMENTS[19730] = Fluid3D([12215,12288,12643,11546],0); -ELEMENTS[19731] = Fluid3D([12288,12907,12643,13322],0); -ELEMENTS[19732] = Fluid3D([12907,12215,12643,13146],0); -ELEMENTS[19733] = Fluid3D([12643,12215,11546,11623],0); -ELEMENTS[19734] = Fluid3D([12643,12215,11623,12287],0); -ELEMENTS[19735] = Fluid3D([12643,12215,12287,13146],0); -ELEMENTS[19736] = Fluid3D([11546,12643,11623,11636],0); -ELEMENTS[19737] = Fluid3D([12643,11623,11636,12379],0); -ELEMENTS[19738] = Fluid3D([11623,11636,12379,11454],0); -ELEMENTS[19739] = Fluid3D([11623,11636,11454,10746],0); -ELEMENTS[19740] = Fluid3D([11623,11636,10746,11546],0); -ELEMENTS[19741] = Fluid3D([12379,11623,11454,11931],0); -ELEMENTS[19742] = Fluid3D([11454,11623,10746,10957],0); -ELEMENTS[19743] = Fluid3D([12379,11623,11931,12287],0); -ELEMENTS[19744] = Fluid3D([11931,12379,12287,12865],0); -ELEMENTS[19745] = Fluid3D([12287,11931,12865,12702],0); -ELEMENTS[19746] = Fluid3D([12379,12287,12865,13146],0); -ELEMENTS[19747] = Fluid3D([12287,12865,13146,12702],0); -ELEMENTS[19748] = Fluid3D([12379,12287,13146,12643],0); -ELEMENTS[19749] = Fluid3D([12379,11623,12287,12643],0); -ELEMENTS[19750] = Fluid3D([11623,11931,12287,11900],0); -ELEMENTS[19751] = Fluid3D([11454,11623,10957,11931],0); -ELEMENTS[19752] = Fluid3D([11636,11454,10746,11439],0); -ELEMENTS[19753] = Fluid3D([12865,13146,12702,13465],0); -ELEMENTS[19754] = Fluid3D([12865,13146,13465,13669],0); -ELEMENTS[19755] = Fluid3D([13465,12865,13669,12690],0); -ELEMENTS[19756] = Fluid3D([12702,12865,13465,12690],0); -ELEMENTS[19757] = Fluid3D([11623,10957,11931,10959],0); -ELEMENTS[19758] = Fluid3D([11623,10746,10957,10384],0); -ELEMENTS[19759] = Fluid3D([11931,12865,12702,12690],0); -ELEMENTS[19760] = Fluid3D([10957,11454,11931,11286],0); -ELEMENTS[19761] = Fluid3D([11931,10957,11286,11820],0); -ELEMENTS[19762] = Fluid3D([11636,12379,11454,11439],0); -ELEMENTS[19763] = Fluid3D([11931,12379,12865,12405],0); -ELEMENTS[19764] = Fluid3D([11454,11931,11286,12405],0); -ELEMENTS[19765] = Fluid3D([12865,12379,13146,13304],0); -ELEMENTS[19766] = Fluid3D([11454,12379,11931,12405],0); -ELEMENTS[19767] = Fluid3D([10957,11454,11286,10527],0); -ELEMENTS[19768] = Fluid3D([10746,11454,10957,10527],0); -ELEMENTS[19769] = Fluid3D([12215,11546,11623,10384],0); -ELEMENTS[19770] = Fluid3D([12215,12288,11546,11313],0); -ELEMENTS[19771] = Fluid3D([12215,12288,11313,12366],0); -ELEMENTS[19772] = Fluid3D([12288,11546,11313,11538],0); -ELEMENTS[19773] = Fluid3D([11313,12288,11538,12011],0); -ELEMENTS[19774] = Fluid3D([11313,12288,12011,12366],0); -ELEMENTS[19775] = Fluid3D([12288,11546,11538,11974],0); -ELEMENTS[19776] = Fluid3D([11538,11313,12011,10981],0); -ELEMENTS[19777] = Fluid3D([11538,11313,10981,10754],0); -ELEMENTS[19778] = Fluid3D([12011,11538,10981,11628],0); -ELEMENTS[19779] = Fluid3D([12011,11538,11628,12258],0); -ELEMENTS[19780] = Fluid3D([11538,11628,12258,11479],0); -ELEMENTS[19781] = Fluid3D([12011,11538,12258,12288],0); -ELEMENTS[19782] = Fluid3D([11628,12011,12258,12043],0); -ELEMENTS[19783] = Fluid3D([11538,12258,12288,11974],0); -ELEMENTS[19784] = Fluid3D([11538,12258,11974,11479],0); -ELEMENTS[19785] = Fluid3D([11313,12011,10981,11407],0); -ELEMENTS[19786] = Fluid3D([11313,12011,11407,12366],0); -ELEMENTS[19787] = Fluid3D([10981,11313,11407,10631],0); -ELEMENTS[19788] = Fluid3D([10981,11313,10631,10567],0); -ELEMENTS[19789] = Fluid3D([11313,10631,10567,10384],0); -ELEMENTS[19790] = Fluid3D([10631,10981,10567,10214],0); -ELEMENTS[19791] = Fluid3D([10981,10567,10214,10754],0); -ELEMENTS[19792] = Fluid3D([10631,10981,10214,9747],0); -ELEMENTS[19793] = Fluid3D([11313,11407,10631,11292],0); -ELEMENTS[19794] = Fluid3D([11407,10981,10631,10882],0); -ELEMENTS[19795] = Fluid3D([10567,10214,10754,9695],0); -ELEMENTS[19796] = Fluid3D([10567,10214,9695,10631],0); -ELEMENTS[19797] = Fluid3D([9695,10567,10631,10384],0); -ELEMENTS[19798] = Fluid3D([9695,10567,10384,9886],0); -ELEMENTS[19799] = Fluid3D([10981,11313,10567,10754],0); -ELEMENTS[19800] = Fluid3D([10754,10567,9695,9886],0); -ELEMENTS[19801] = Fluid3D([11538,10981,11628,10452],0); -ELEMENTS[19802] = Fluid3D([11546,12215,11313,10384],0); -ELEMENTS[19803] = Fluid3D([11546,11313,11538,10754],0); -ELEMENTS[19804] = Fluid3D([11538,11546,10754,11974],0); -ELEMENTS[19805] = Fluid3D([10754,11538,11974,11479],0); -ELEMENTS[19806] = Fluid3D([12215,11623,12287,11900],0); -ELEMENTS[19807] = Fluid3D([12288,12643,11546,11974],0); -ELEMENTS[19808] = Fluid3D([12011,10981,11407,11545],0); -ELEMENTS[19809] = Fluid3D([11407,12011,11545,12703],0); -ELEMENTS[19810] = Fluid3D([10981,11407,11545,10882],0); -ELEMENTS[19811] = Fluid3D([11407,11545,10882,12703],0); -ELEMENTS[19812] = Fluid3D([12011,10981,11545,11628],0); -ELEMENTS[19813] = Fluid3D([12011,11545,12703,12754],0); -ELEMENTS[19814] = Fluid3D([11407,12011,12703,12366],0); -ELEMENTS[19815] = Fluid3D([12418,12855,11928,11775],0); -ELEMENTS[19816] = Fluid3D([11415,10790,10937,10389],0); -ELEMENTS[19817] = Fluid3D([11415,10790,10389,10401],0); -ELEMENTS[19818] = Fluid3D([10790,10937,10389,9984],0); -ELEMENTS[19819] = Fluid3D([10790,10937,9984,10882],0); -ELEMENTS[19820] = Fluid3D([10389,10790,9984,9850],0); -ELEMENTS[19821] = Fluid3D([10790,9984,9850,10029],0); -ELEMENTS[19822] = Fluid3D([10389,10790,9850,10401],0); -ELEMENTS[19823] = Fluid3D([9850,10389,10401,9467],0); -ELEMENTS[19824] = Fluid3D([9984,9850,10029,9151],0); -ELEMENTS[19825] = Fluid3D([9984,9850,9151,9467],0); -ELEMENTS[19826] = Fluid3D([10029,9984,9151,9602],0); -ELEMENTS[19827] = Fluid3D([9984,9151,9602,9231],0); -ELEMENTS[19828] = Fluid3D([10790,9984,10029,10882],0); -ELEMENTS[19829] = Fluid3D([9850,10029,9151,9109],0); -ELEMENTS[19830] = Fluid3D([10029,9984,9602,10882],0); -ELEMENTS[19831] = Fluid3D([9984,10389,9850,9467],0); -ELEMENTS[19832] = Fluid3D([9151,10029,9602,9109],0); -ELEMENTS[19833] = Fluid3D([10937,11415,10389,11349],0); -ELEMENTS[19834] = Fluid3D([10937,10389,9984,10096],0); -ELEMENTS[19835] = Fluid3D([9984,10937,10096,10233],0); -ELEMENTS[19836] = Fluid3D([10389,9984,10096,9467],0); -ELEMENTS[19837] = Fluid3D([10096,10389,9467,10245],0); -ELEMENTS[19838] = Fluid3D([9467,10096,10245,9055],0); -ELEMENTS[19839] = Fluid3D([10096,10389,10245,10937],0); -ELEMENTS[19840] = Fluid3D([9850,10790,10029,10699],0); -ELEMENTS[19841] = Fluid3D([14247,13883,13449,13736],0); -ELEMENTS[19842] = Fluid3D([11696,11687,12303,11424],0); -ELEMENTS[19843] = Fluid3D([12771,12906,11973,12703],0); -ELEMENTS[19844] = Fluid3D([11973,12771,12703,11696],0); -ELEMENTS[19845] = Fluid3D([12771,12906,12703,13736],0); -ELEMENTS[19846] = Fluid3D([12906,11973,12703,12366],0); -ELEMENTS[19847] = Fluid3D([12771,12703,11696,12303],0); -ELEMENTS[19848] = Fluid3D([16356,16389,16303,16749],0); -ELEMENTS[19849] = Fluid3D([13883,14095,13468,13880],0); -ELEMENTS[19850] = Fluid3D([16092,16356,16113,16534],0); -ELEMENTS[19851] = Fluid3D([16092,16356,16534,16391],0); -ELEMENTS[19852] = Fluid3D([16534,16092,16391,16163],0); -ELEMENTS[19853] = Fluid3D([16534,16092,16163,16334],0); -ELEMENTS[19854] = Fluid3D([16092,16391,16163,16026],0); -ELEMENTS[19855] = Fluid3D([16113,16092,16534,16334],0); -ELEMENTS[19856] = Fluid3D([16356,16113,16534,16881],0); -ELEMENTS[19857] = Fluid3D([16092,16163,16334,15705],0); -ELEMENTS[19858] = Fluid3D([16092,16163,15705,15390],0); -ELEMENTS[19859] = Fluid3D([14095,14247,13449,14155],0); -ELEMENTS[19860] = Fluid3D([11696,10882,11424,11545],0); -ELEMENTS[19861] = Fluid3D([10882,11424,11545,10652],0); -ELEMENTS[19862] = Fluid3D([11424,11545,10652,12043],0); -ELEMENTS[19863] = Fluid3D([11545,10882,10652,10981],0); -ELEMENTS[19864] = Fluid3D([10882,11424,10652,10029],0); -ELEMENTS[19865] = Fluid3D([11424,11696,11545,12303],0); -ELEMENTS[19866] = Fluid3D([15274,15855,15629,15957],0); -ELEMENTS[19867] = Fluid3D([12000,12752,12583,11928],0); -ELEMENTS[19868] = Fluid3D([16356,15985,16389,16749],0); -ELEMENTS[19869] = Fluid3D([10882,10790,11424,10029],0); -ELEMENTS[19870] = Fluid3D([13449,12906,12771,13736],0); -ELEMENTS[19871] = Fluid3D([13468,12418,13234,13230],0); -ELEMENTS[19872] = Fluid3D([13468,12418,13230,13515],0); -ELEMENTS[19873] = Fluid3D([12418,13234,13230,13016],0); -ELEMENTS[19874] = Fluid3D([13234,13230,13016,13880],0); -ELEMENTS[19875] = Fluid3D([13230,13016,13880,13515],0); -ELEMENTS[19876] = Fluid3D([13230,13016,13515,12587],0); -ELEMENTS[19877] = Fluid3D([13880,13230,13515,13468],0); -ELEMENTS[19878] = Fluid3D([13515,13230,12587,12418],0); -ELEMENTS[19879] = Fluid3D([13234,13230,13880,13468],0); -ELEMENTS[19880] = Fluid3D([13230,13016,12587,12418],0); -ELEMENTS[19881] = Fluid3D([13880,13234,13468,13883],0); -ELEMENTS[19882] = Fluid3D([11687,12372,12303,12606],0); -ELEMENTS[19883] = Fluid3D([11687,12372,12606,12301],0); -ELEMENTS[19884] = Fluid3D([12372,12303,12606,13306],0); -ELEMENTS[19885] = Fluid3D([12303,11687,12606,12154],0); -ELEMENTS[19886] = Fluid3D([11687,12606,12154,12220],0); -ELEMENTS[19887] = Fluid3D([12303,11687,12154,11424],0); -ELEMENTS[19888] = Fluid3D([12606,12303,12154,12980],0); -ELEMENTS[19889] = Fluid3D([12154,12606,12980,12220],0); -ELEMENTS[19890] = Fluid3D([12855,12752,11928,12583],0); -ELEMENTS[19891] = Fluid3D([11850,11463,12480,11359],0); -ELEMENTS[19892] = Fluid3D([9462,10133,9238,10098],0); -ELEMENTS[19893] = Fluid3D([10274,9400,10322,10593],0); -ELEMENTS[19894] = Fluid3D([13175,13160,12537,13604],0); -ELEMENTS[19895] = Fluid3D([12739,12459,12794,13336],0); -ELEMENTS[19896] = Fluid3D([8874,8396,7984,8170],0); -ELEMENTS[19897] = Fluid3D([7984,8874,8170,8295],0); -ELEMENTS[19898] = Fluid3D([8874,8170,8295,8929],0); -ELEMENTS[19899] = Fluid3D([8874,8170,8929,9069],0); -ELEMENTS[19900] = Fluid3D([8874,8396,8170,9069],0); -ELEMENTS[19901] = Fluid3D([8170,8295,8929,8062],0); -ELEMENTS[19902] = Fluid3D([8170,8295,8062,7467],0); -ELEMENTS[19903] = Fluid3D([8929,8170,8062,8469],0); -ELEMENTS[19904] = Fluid3D([8929,8170,8469,9069],0); -ELEMENTS[19905] = Fluid3D([8062,8170,7467,7293],0); -ELEMENTS[19906] = Fluid3D([8062,8170,7293,8469],0); -ELEMENTS[19907] = Fluid3D([8170,7467,7293,7368],0); -ELEMENTS[19908] = Fluid3D([7467,7293,7368,6738],0); -ELEMENTS[19909] = Fluid3D([7467,7293,6738,7090],0); -ELEMENTS[19910] = Fluid3D([7467,7293,7090,8062],0); -ELEMENTS[19911] = Fluid3D([8170,7467,7368,7984],0); -ELEMENTS[19912] = Fluid3D([8295,8929,8062,8598],0); -ELEMENTS[19913] = Fluid3D([8062,8295,8598,7775],0); -ELEMENTS[19914] = Fluid3D([8929,8062,8598,9062],0); -ELEMENTS[19915] = Fluid3D([8929,8062,9062,8469],0); -ELEMENTS[19916] = Fluid3D([8598,8062,7775,8228],0); -ELEMENTS[19917] = Fluid3D([8062,7775,8228,7090],0); -ELEMENTS[19918] = Fluid3D([8598,8062,8228,9062],0); -ELEMENTS[19919] = Fluid3D([8295,8929,8598,9211],0); -ELEMENTS[19920] = Fluid3D([8295,8929,9211,8874],0); -ELEMENTS[19921] = Fluid3D([8929,8598,9211,9613],0); -ELEMENTS[19922] = Fluid3D([9211,8929,9613,9473],0); -ELEMENTS[19923] = Fluid3D([9211,8929,9473,8874],0); -ELEMENTS[19924] = Fluid3D([8929,9473,8874,9069],0); -ELEMENTS[19925] = Fluid3D([9473,9211,8874,9581],0); -ELEMENTS[19926] = Fluid3D([8929,9613,9473,10254],0); -ELEMENTS[19927] = Fluid3D([9473,8874,9069,9313],0); -ELEMENTS[19928] = Fluid3D([8929,8598,9613,9062],0); -ELEMENTS[19929] = Fluid3D([8598,9211,9613,9224],0); -ELEMENTS[19930] = Fluid3D([8598,9211,9224,8610],0); -ELEMENTS[19931] = Fluid3D([9211,9224,8610,9501],0); -ELEMENTS[19932] = Fluid3D([9211,9613,9224,10298],0); -ELEMENTS[19933] = Fluid3D([8598,9211,8610,8295],0); -ELEMENTS[19934] = Fluid3D([9211,9224,9501,10298],0); -ELEMENTS[19935] = Fluid3D([8062,8295,7775,7467],0); -ELEMENTS[19936] = Fluid3D([7293,7368,6738,6957],0); -ELEMENTS[19937] = Fluid3D([7293,7368,6957,7815],0); -ELEMENTS[19938] = Fluid3D([6957,7293,7815,7420],0); -ELEMENTS[19939] = Fluid3D([7368,6738,6957,6299],0); -ELEMENTS[19940] = Fluid3D([6957,7293,7420,6460],0); -ELEMENTS[19941] = Fluid3D([6738,7293,6957,6460],0); -ELEMENTS[19942] = Fluid3D([7293,7368,7815,8170],0); -ELEMENTS[19943] = Fluid3D([7815,6957,7420,7291],0); -ELEMENTS[19944] = Fluid3D([8610,9211,9501,8813],0); -ELEMENTS[19945] = Fluid3D([9501,8610,8813,8663],0); -ELEMENTS[19946] = Fluid3D([8813,9501,8663,9412],0); -ELEMENTS[19947] = Fluid3D([8813,9501,9412,9581],0); -ELEMENTS[19948] = Fluid3D([9412,8813,9581,8736],0); -ELEMENTS[19949] = Fluid3D([8813,9581,8736,8874],0); -ELEMENTS[19950] = Fluid3D([8813,9501,9581,9211],0); -ELEMENTS[19951] = Fluid3D([9501,9412,9581,10317],0); -ELEMENTS[19952] = Fluid3D([9412,9581,10317,9482],0); -ELEMENTS[19953] = Fluid3D([9412,9581,9482,8736],0); -ELEMENTS[19954] = Fluid3D([9581,9501,10317,10500],0); -ELEMENTS[19955] = Fluid3D([10317,9581,10500,10349],0); -ELEMENTS[19956] = Fluid3D([9581,8813,9211,8874],0); -ELEMENTS[19957] = Fluid3D([9412,8813,8736,8303],0); -ELEMENTS[19958] = Fluid3D([8813,8736,8303,7981],0); -ELEMENTS[19959] = Fluid3D([8813,8736,7981,8874],0); -ELEMENTS[19960] = Fluid3D([8303,8813,7981,8663],0); -ELEMENTS[19961] = Fluid3D([8303,8813,8663,9412],0); -ELEMENTS[19962] = Fluid3D([8736,8303,7981,7975],0); -ELEMENTS[19963] = Fluid3D([7981,8736,7975,7960],0); -ELEMENTS[19964] = Fluid3D([8736,7975,7960,8950],0); -ELEMENTS[19965] = Fluid3D([7975,7981,7960,7259],0); -ELEMENTS[19966] = Fluid3D([7960,7975,7259,7458],0); -ELEMENTS[19967] = Fluid3D([7960,7975,7458,8358],0); -ELEMENTS[19968] = Fluid3D([7960,7975,8358,8950],0); -ELEMENTS[19969] = Fluid3D([7975,7259,7458,7336],0); -ELEMENTS[19970] = Fluid3D([8358,7960,8950,8450],0); -ELEMENTS[19971] = Fluid3D([7975,7458,8358,7837],0); -ELEMENTS[19972] = Fluid3D([7975,7259,7336,7981],0); -ELEMENTS[19973] = Fluid3D([7458,7975,7336,7837],0); -ELEMENTS[19974] = Fluid3D([7975,7336,7837,8303],0); -ELEMENTS[19975] = Fluid3D([7336,7458,7837,7118],0); -ELEMENTS[19976] = Fluid3D([7837,7336,7118,7508],0); -ELEMENTS[19977] = Fluid3D([7837,7336,7508,7930],0); -ELEMENTS[19978] = Fluid3D([7837,7336,7930,8303],0); -ELEMENTS[19979] = Fluid3D([8358,7975,7837,8706],0); -ELEMENTS[19980] = Fluid3D([8358,7975,8706,8950],0); -ELEMENTS[19981] = Fluid3D([8706,8358,8950,9353],0); -ELEMENTS[19982] = Fluid3D([7837,8358,8706,8661],0); -ELEMENTS[19983] = Fluid3D([8358,8706,8661,9353],0); -ELEMENTS[19984] = Fluid3D([7975,7837,8706,8303],0); -ELEMENTS[19985] = Fluid3D([8706,7837,8661,8757],0); -ELEMENTS[19986] = Fluid3D([8706,7837,8757,7930],0); -ELEMENTS[19987] = Fluid3D([8706,8661,9353,8757],0); -ELEMENTS[19988] = Fluid3D([7458,7960,8358,8282],0); -ELEMENTS[19989] = Fluid3D([7837,8757,7930,7508],0); -ELEMENTS[19990] = Fluid3D([8358,8950,9353,8282],0); -ELEMENTS[19991] = Fluid3D([7336,7508,7930,7238],0); -ELEMENTS[19992] = Fluid3D([7118,7837,7508,7374],0); -ELEMENTS[19993] = Fluid3D([7336,7118,7508,6740],0); -ELEMENTS[19994] = Fluid3D([8358,8950,8282,8450],0); -ELEMENTS[19995] = Fluid3D([7837,8358,8661,7904],0); -ELEMENTS[19996] = Fluid3D([7336,7508,7238,6740],0); -ELEMENTS[19997] = Fluid3D([7336,7118,6740,6642],0); -ELEMENTS[19998] = Fluid3D([7336,7118,6642,7458],0); -ELEMENTS[19999] = Fluid3D([7930,7336,7238,7617],0); -ELEMENTS[20000] = Fluid3D([7930,7336,7617,8303],0); -ELEMENTS[20001] = Fluid3D([7617,7930,8303,8142],0); -ELEMENTS[20002] = Fluid3D([7930,8303,8142,8865],0); -ELEMENTS[20003] = Fluid3D([7930,8303,8865,8757],0); -ELEMENTS[20004] = Fluid3D([8303,7617,8142,8663],0); -ELEMENTS[20005] = Fluid3D([8142,8303,8663,8865],0); -ELEMENTS[20006] = Fluid3D([8663,8142,8865,8875],0); -ELEMENTS[20007] = Fluid3D([8663,8142,8875,8272],0); -ELEMENTS[20008] = Fluid3D([8663,8142,8272,7952],0); -ELEMENTS[20009] = Fluid3D([8663,8142,7952,7617],0); -ELEMENTS[20010] = Fluid3D([8142,7952,7617,7328],0); -ELEMENTS[20011] = Fluid3D([7952,7617,7328,7199],0); -ELEMENTS[20012] = Fluid3D([7952,7617,7199,7981],0); -ELEMENTS[20013] = Fluid3D([8303,8663,8865,9412],0); -ELEMENTS[20014] = Fluid3D([8142,8272,7952,7328],0); -ELEMENTS[20015] = Fluid3D([8142,7930,8865,8180],0); -ELEMENTS[20016] = Fluid3D([8142,8875,8272,8027],0); -ELEMENTS[20017] = Fluid3D([8272,8663,7952,8610],0); -ELEMENTS[20018] = Fluid3D([8663,7952,8610,8813],0); -ELEMENTS[20019] = Fluid3D([7930,8865,8180,8757],0); -ELEMENTS[20020] = Fluid3D([8272,8142,8027,7328],0); -ELEMENTS[20021] = Fluid3D([8142,8875,8027,8180],0); -ELEMENTS[20022] = Fluid3D([7952,7617,7981,8303],0); -ELEMENTS[20023] = Fluid3D([7617,7981,8303,7336],0); -ELEMENTS[20024] = Fluid3D([7328,7952,7199,7426],0); -ELEMENTS[20025] = Fluid3D([8875,8663,8272,9257],0); -ELEMENTS[20026] = Fluid3D([8142,7930,8180,7238],0); -ELEMENTS[20027] = Fluid3D([8663,8272,9257,8610],0); -ELEMENTS[20028] = Fluid3D([7328,7952,7426,8272],0); -ELEMENTS[20029] = Fluid3D([7952,7199,7426,7775],0); -ELEMENTS[20030] = Fluid3D([7617,7328,7199,6814],0); -ELEMENTS[20031] = Fluid3D([7617,7930,8142,7238],0); -ELEMENTS[20032] = Fluid3D([7199,7617,6814,7259],0); -ELEMENTS[20033] = Fluid3D([7952,7617,8303,8663],0); -ELEMENTS[20034] = Fluid3D([8706,7975,8303,8736],0); -ELEMENTS[20035] = Fluid3D([8706,7975,8736,8950],0); -ELEMENTS[20036] = Fluid3D([8875,8663,9257,9619],0); -ELEMENTS[20037] = Fluid3D([8875,8663,9619,8865],0); -ELEMENTS[20038] = Fluid3D([8706,7837,7930,8303],0); -ELEMENTS[20039] = Fluid3D([7336,7238,7617,6814],0); -ELEMENTS[20040] = Fluid3D([7238,7617,6814,7328],0); -ELEMENTS[20041] = Fluid3D([9501,9581,9211,10298],0); -ELEMENTS[20042] = Fluid3D([6814,7238,7328,6656],0); -ELEMENTS[20043] = Fluid3D([6814,7238,6656,6740],0); -ELEMENTS[20044] = Fluid3D([8661,8358,9353,8460],0); -ELEMENTS[20045] = Fluid3D([10500,10317,10349,11223],0); -ELEMENTS[20046] = Fluid3D([10500,10317,11223,11566],0); -ELEMENTS[20047] = Fluid3D([9501,9412,10317,9619],0); -ELEMENTS[20048] = Fluid3D([9501,9412,9619,8663],0); -ELEMENTS[20049] = Fluid3D([9412,9619,8663,8865],0); -ELEMENTS[20050] = Fluid3D([9412,9619,8865,10066],0); -ELEMENTS[20051] = Fluid3D([9412,9619,10066,10317],0); -ELEMENTS[20052] = Fluid3D([7458,7837,7118,7904],0); -ELEMENTS[20053] = Fluid3D([6740,7336,6642,6814],0); -ELEMENTS[20054] = Fluid3D([7837,8661,8757,8368],0); -ELEMENTS[20055] = Fluid3D([8663,9257,9619,9501],0); -ELEMENTS[20056] = Fluid3D([7259,7960,7458,7135],0); -ELEMENTS[20057] = Fluid3D([7960,7458,7135,7717],0); -ELEMENTS[20058] = Fluid3D([8865,8142,8180,8875],0); -ELEMENTS[20059] = Fluid3D([7199,7328,7426,6617],0); -ELEMENTS[20060] = Fluid3D([7508,7930,7238,8180],0); -ELEMENTS[20061] = Fluid3D([7426,7199,6617,6776],0); -ELEMENTS[20062] = Fluid3D([7199,6617,6776,6305],0); -ELEMENTS[20063] = Fluid3D([6776,7199,6305,6885],0); -ELEMENTS[20064] = Fluid3D([6776,7199,6885,7775],0); -ELEMENTS[20065] = Fluid3D([7199,6305,6885,6737],0); -ELEMENTS[20066] = Fluid3D([6885,7199,6737,7259],0); -ELEMENTS[20067] = Fluid3D([6305,6776,6885,6152],0); -ELEMENTS[20068] = Fluid3D([7199,6305,6737,6814],0); -ELEMENTS[20069] = Fluid3D([6737,7199,6814,7259],0); -ELEMENTS[20070] = Fluid3D([6305,6737,6814,6139],0); -ELEMENTS[20071] = Fluid3D([6737,6814,6139,6642],0); -ELEMENTS[20072] = Fluid3D([6776,6885,6152,7090],0); -ELEMENTS[20073] = Fluid3D([7426,7199,6776,7775],0); -ELEMENTS[20074] = Fluid3D([6305,6776,6152,6038],0); -ELEMENTS[20075] = Fluid3D([6776,6152,6038,6336],0); -ELEMENTS[20076] = Fluid3D([6152,6038,6336,5603],0); -ELEMENTS[20077] = Fluid3D([6776,6152,6336,7090],0); -ELEMENTS[20078] = Fluid3D([7199,6305,6814,6617],0); -ELEMENTS[20079] = Fluid3D([6305,6885,6737,6189],0); -ELEMENTS[20080] = Fluid3D([6737,6305,6189,6139],0); -ELEMENTS[20081] = Fluid3D([6885,6305,6152,6189],0); -ELEMENTS[20082] = Fluid3D([8272,8875,9257,9148],0); -ELEMENTS[20083] = Fluid3D([6885,6737,6189,6772],0); -ELEMENTS[20084] = Fluid3D([6885,6737,6772,7259],0); -ELEMENTS[20085] = Fluid3D([6737,6772,7259,6481],0); -ELEMENTS[20086] = Fluid3D([7259,6737,6481,6642],0); -ELEMENTS[20087] = Fluid3D([6481,7259,6642,7135],0); -ELEMENTS[20088] = Fluid3D([6772,7259,6481,7135],0); -ELEMENTS[20089] = Fluid3D([6737,6481,6642,6139],0); -ELEMENTS[20090] = Fluid3D([6481,6642,6139,5941],0); -ELEMENTS[20091] = Fluid3D([6481,6642,5941,6428],0); -ELEMENTS[20092] = Fluid3D([6481,6642,6428,7135],0); -ELEMENTS[20093] = Fluid3D([5941,6481,6428,5995],0); -ELEMENTS[20094] = Fluid3D([6481,6428,5995,7135],0); -ELEMENTS[20095] = Fluid3D([5941,6481,5995,6189],0); -ELEMENTS[20096] = Fluid3D([6642,5941,6428,6208],0); -ELEMENTS[20097] = Fluid3D([6428,6642,6208,7118],0); -ELEMENTS[20098] = Fluid3D([6737,6772,6481,6189],0); -ELEMENTS[20099] = Fluid3D([6642,5941,6208,6058],0); -ELEMENTS[20100] = Fluid3D([6642,5941,6058,6139],0); -ELEMENTS[20101] = Fluid3D([6208,6642,6058,7118],0); -ELEMENTS[20102] = Fluid3D([6481,6737,6189,6139],0); -ELEMENTS[20103] = Fluid3D([7458,8358,7837,7904],0); -ELEMENTS[20104] = Fluid3D([7617,8142,7328,7238],0); -ELEMENTS[20105] = Fluid3D([7118,6740,6642,6058],0); -ELEMENTS[20106] = Fluid3D([6740,6642,6058,6139],0); -ELEMENTS[20107] = Fluid3D([7328,6814,6656,6617],0); -ELEMENTS[20108] = Fluid3D([7930,8706,8303,8757],0); -ELEMENTS[20109] = Fluid3D([7328,7426,6617,7123],0); -ELEMENTS[20110] = Fluid3D([7328,7426,7123,8272],0); -ELEMENTS[20111] = Fluid3D([7426,6617,7123,6815],0); -ELEMENTS[20112] = Fluid3D([7426,6617,6815,6776],0); -ELEMENTS[20113] = Fluid3D([7118,7508,6740,6756],0); -ELEMENTS[20114] = Fluid3D([7508,6740,6756,6886],0); -ELEMENTS[20115] = Fluid3D([7508,6740,6886,7238],0); -ELEMENTS[20116] = Fluid3D([6740,7118,6756,6518],0); -ELEMENTS[20117] = Fluid3D([6740,6756,6886,6165],0); -ELEMENTS[20118] = Fluid3D([6740,6756,6165,6058],0); -ELEMENTS[20119] = Fluid3D([6165,6740,6058,6143],0); -ELEMENTS[20120] = Fluid3D([6740,6058,6143,6139],0); -ELEMENTS[20121] = Fluid3D([6058,6165,6143,5584],0); -ELEMENTS[20122] = Fluid3D([6143,6058,5584,5714],0); -ELEMENTS[20123] = Fluid3D([6143,6058,5714,6139],0); -ELEMENTS[20124] = Fluid3D([6058,5714,6139,5941],0); -ELEMENTS[20125] = Fluid3D([5714,6143,6139,5959],0); -ELEMENTS[20126] = Fluid3D([6139,5714,5959,5652],0); -ELEMENTS[20127] = Fluid3D([6139,5714,5652,5941],0); -ELEMENTS[20128] = Fluid3D([5714,5959,5652,5312],0); -ELEMENTS[20129] = Fluid3D([5714,5959,5312,5338],0); -ELEMENTS[20130] = Fluid3D([5652,5714,5312,5158],0); -ELEMENTS[20131] = Fluid3D([5652,5714,5158,5941],0); -ELEMENTS[20132] = Fluid3D([5714,5312,5158,5338],0); -ELEMENTS[20133] = Fluid3D([5959,6139,5652,6305],0); -ELEMENTS[20134] = Fluid3D([6058,5584,5714,5461],0); -ELEMENTS[20135] = Fluid3D([6165,6740,6143,6886],0); -ELEMENTS[20136] = Fluid3D([6058,5584,5461,5720],0); -ELEMENTS[20137] = Fluid3D([6058,5584,5720,6165],0); -ELEMENTS[20138] = Fluid3D([5714,6143,5959,5338],0); -ELEMENTS[20139] = Fluid3D([5714,6058,5461,5941],0); -ELEMENTS[20140] = Fluid3D([6058,5461,5941,6208],0); -ELEMENTS[20141] = Fluid3D([5312,5652,5158,5050],0); -ELEMENTS[20142] = Fluid3D([5652,5158,5050,5270],0); -ELEMENTS[20143] = Fluid3D([5652,5158,5270,5610],0); -ELEMENTS[20144] = Fluid3D([5652,5158,5610,5941],0); -ELEMENTS[20145] = Fluid3D([5584,6143,5714,5338],0); -ELEMENTS[20146] = Fluid3D([5050,5652,5270,5478],0); -ELEMENTS[20147] = Fluid3D([5050,5652,5478,5522],0); -ELEMENTS[20148] = Fluid3D([5584,5461,5720,5115],0); -ELEMENTS[20149] = Fluid3D([5584,5461,5115,4800],0); -ELEMENTS[20150] = Fluid3D([5652,5478,5522,6152],0); -ELEMENTS[20151] = Fluid3D([5050,5652,5522,5312],0); -ELEMENTS[20152] = Fluid3D([5158,5050,5270,4699],0); -ELEMENTS[20153] = Fluid3D([5270,5158,4699,5164],0); -ELEMENTS[20154] = Fluid3D([5158,5050,4699,4861],0); -ELEMENTS[20155] = Fluid3D([5270,5158,5164,5610],0); -ELEMENTS[20156] = Fluid3D([5158,4699,5164,4669],0); -ELEMENTS[20157] = Fluid3D([5270,5652,5610,6189],0); -ELEMENTS[20158] = Fluid3D([5959,5652,5312,5522],0); -ELEMENTS[20159] = Fluid3D([5584,5714,5461,4800],0); -ELEMENTS[20160] = Fluid3D([5720,5584,5115,5310],0); -ELEMENTS[20161] = Fluid3D([5584,5115,5310,4800],0); -ELEMENTS[20162] = Fluid3D([5115,5310,4800,4688],0); -ELEMENTS[20163] = Fluid3D([5720,5584,5310,6165],0); -ELEMENTS[20164] = Fluid3D([5584,5310,6165,5846],0); -ELEMENTS[20165] = Fluid3D([5584,5310,5846,5338],0); -ELEMENTS[20166] = Fluid3D([5584,5310,5338,4800],0); -ELEMENTS[20167] = Fluid3D([7328,7199,6814,6617],0); -ELEMENTS[20168] = Fluid3D([5158,5312,5050,4861],0); -ELEMENTS[20169] = Fluid3D([5312,5050,4861,4920],0); -ELEMENTS[20170] = Fluid3D([5158,5312,4861,5338],0); -ELEMENTS[20171] = Fluid3D([5312,4861,5338,5380],0); -ELEMENTS[20172] = Fluid3D([5312,4861,5380,4920],0); -ELEMENTS[20173] = Fluid3D([5338,5312,5380,5959],0); -ELEMENTS[20174] = Fluid3D([5312,5380,5959,5522],0); -ELEMENTS[20175] = Fluid3D([5312,5380,5522,4920],0); -ELEMENTS[20176] = Fluid3D([5461,6058,5720,6208],0); -ELEMENTS[20177] = Fluid3D([9257,8875,9619,10414],0); -ELEMENTS[20178] = Fluid3D([5652,5270,5478,6189],0); -ELEMENTS[20179] = Fluid3D([8875,8272,8027,9148],0); -ELEMENTS[20180] = Fluid3D([7259,7458,7336,6642],0); -ELEMENTS[20181] = Fluid3D([6428,5941,5995,5824],0); -ELEMENTS[20182] = Fluid3D([5995,6428,5824,6184],0); -ELEMENTS[20183] = Fluid3D([5995,6428,6184,6898],0); -ELEMENTS[20184] = Fluid3D([5824,5995,6184,5847],0); -ELEMENTS[20185] = Fluid3D([5941,5995,5824,5610],0); -ELEMENTS[20186] = Fluid3D([5941,5995,5610,6189],0); -ELEMENTS[20187] = Fluid3D([8610,9211,8813,8295],0); -ELEMENTS[20188] = Fluid3D([6428,5824,6184,6520],0); -ELEMENTS[20189] = Fluid3D([8865,8303,9412,8706],0); -ELEMENTS[20190] = Fluid3D([5478,5050,5522,5068],0); -ELEMENTS[20191] = Fluid3D([5050,5522,5068,4920],0); -ELEMENTS[20192] = Fluid3D([5478,5050,5068,4746],0); -ELEMENTS[20193] = Fluid3D([5522,5478,5068,5603],0); -ELEMENTS[20194] = Fluid3D([8303,7981,7975,7336],0); -ELEMENTS[20195] = Fluid3D([7458,7259,7135,6642],0); -ELEMENTS[20196] = Fluid3D([7123,7426,6815,7633],0); -ELEMENTS[20197] = Fluid3D([7123,7426,7633,8272],0); -ELEMENTS[20198] = Fluid3D([7426,6815,7633,7445],0); -ELEMENTS[20199] = Fluid3D([7426,6815,7445,6776],0); -ELEMENTS[20200] = Fluid3D([7633,7426,7445,8367],0); -ELEMENTS[20201] = Fluid3D([7633,7426,8367,8272],0); -ELEMENTS[20202] = Fluid3D([7426,7445,8367,7775],0); -ELEMENTS[20203] = Fluid3D([6815,7123,7633,6584],0); -ELEMENTS[20204] = Fluid3D([6815,7633,7445,7146],0); -ELEMENTS[20205] = Fluid3D([7445,6815,7146,6591],0); -ELEMENTS[20206] = Fluid3D([7445,6815,6591,6776],0); -ELEMENTS[20207] = Fluid3D([7633,7445,7146,8032],0); -ELEMENTS[20208] = Fluid3D([6815,7633,7146,6584],0); -ELEMENTS[20209] = Fluid3D([7445,7146,8032,7274],0); -ELEMENTS[20210] = Fluid3D([7445,7146,7274,6591],0); -ELEMENTS[20211] = Fluid3D([7274,7445,6591,7153],0); -ELEMENTS[20212] = Fluid3D([7274,7445,7153,8148],0); -ELEMENTS[20213] = Fluid3D([7274,7445,8148,8032],0); -ELEMENTS[20214] = Fluid3D([7445,7633,8367,8032],0); -ELEMENTS[20215] = Fluid3D([7146,7633,8032,7762],0); -ELEMENTS[20216] = Fluid3D([7633,8032,7762,8623],0); -ELEMENTS[20217] = Fluid3D([8032,7762,8623,8426],0); -ELEMENTS[20218] = Fluid3D([7146,7633,7762,7346],0); -ELEMENTS[20219] = Fluid3D([8032,7146,7762,7594],0); -ELEMENTS[20220] = Fluid3D([7633,8032,8623,8367],0); -ELEMENTS[20221] = Fluid3D([7762,7633,8623,7768],0); -ELEMENTS[20222] = Fluid3D([7633,8623,7768,8272],0); -ELEMENTS[20223] = Fluid3D([7762,7633,7768,7346],0); -ELEMENTS[20224] = Fluid3D([7768,7762,7346,8133],0); -ELEMENTS[20225] = Fluid3D([8623,7762,7768,8133],0); -ELEMENTS[20226] = Fluid3D([8170,8295,7467,7984],0); -ELEMENTS[20227] = Fluid3D([7259,7960,7135,6772],0); -ELEMENTS[20228] = Fluid3D([4699,5270,5164,4841],0); -ELEMENTS[20229] = Fluid3D([5270,5164,4841,5345],0); -ELEMENTS[20230] = Fluid3D([4841,5270,5345,4746],0); -ELEMENTS[20231] = Fluid3D([4699,5270,4841,4746],0); -ELEMENTS[20232] = Fluid3D([5164,4699,4841,4465],0); -ELEMENTS[20233] = Fluid3D([4841,5164,4465,4923],0); -ELEMENTS[20234] = Fluid3D([4465,4841,4923,4526],0); -ELEMENTS[20235] = Fluid3D([5164,4699,4465,4669],0); -ELEMENTS[20236] = Fluid3D([4465,4841,4526,4307],0); -ELEMENTS[20237] = Fluid3D([4465,4841,4307,4699],0); -ELEMENTS[20238] = Fluid3D([4841,4526,4307,4580],0); -ELEMENTS[20239] = Fluid3D([4841,4526,4580,5206],0); -ELEMENTS[20240] = Fluid3D([4526,4307,4580,4043],0); -ELEMENTS[20241] = Fluid3D([4307,4580,4043,4195],0); -ELEMENTS[20242] = Fluid3D([4307,4580,4195,4746],0); -ELEMENTS[20243] = Fluid3D([4526,4307,4043,3958],0); -ELEMENTS[20244] = Fluid3D([4526,4307,3958,4465],0); -ELEMENTS[20245] = Fluid3D([4307,4043,3958,3809],0); -ELEMENTS[20246] = Fluid3D([3958,4307,3809,3983],0); -ELEMENTS[20247] = Fluid3D([4307,4043,3809,4195],0); -ELEMENTS[20248] = Fluid3D([4841,5164,4923,5345],0); -ELEMENTS[20249] = Fluid3D([4307,4841,4580,4746],0); -ELEMENTS[20250] = Fluid3D([4923,4465,4526,4338],0); -ELEMENTS[20251] = Fluid3D([4465,4526,4338,3958],0); -ELEMENTS[20252] = Fluid3D([4923,4465,4338,4693],0); -ELEMENTS[20253] = Fluid3D([4338,4923,4693,4798],0); -ELEMENTS[20254] = Fluid3D([4338,4923,4798,4564],0); -ELEMENTS[20255] = Fluid3D([4338,4923,4564,4526],0); -ELEMENTS[20256] = Fluid3D([4923,4465,4693,5164],0); -ELEMENTS[20257] = Fluid3D([4465,4338,4693,4150],0); -ELEMENTS[20258] = Fluid3D([4465,4338,4150,3958],0); -ELEMENTS[20259] = Fluid3D([4338,4693,4150,4272],0); -ELEMENTS[20260] = Fluid3D([4693,4465,4150,4669],0); -ELEMENTS[20261] = Fluid3D([4693,4338,4798,4272],0); -ELEMENTS[20262] = Fluid3D([5270,5164,5345,5610],0); -ELEMENTS[20263] = Fluid3D([4841,4923,4526,5206],0); -ELEMENTS[20264] = Fluid3D([4580,4043,4195,4232],0); -ELEMENTS[20265] = Fluid3D([4580,4043,4232,4361],0); -ELEMENTS[20266] = Fluid3D([4195,4580,4232,4700],0); -ELEMENTS[20267] = Fluid3D([4580,4232,4700,4662],0); -ELEMENTS[20268] = Fluid3D([4232,4700,4662,4424],0); -ELEMENTS[20269] = Fluid3D([4700,4662,4424,5202],0); -ELEMENTS[20270] = Fluid3D([4232,4700,4424,4110],0); -ELEMENTS[20271] = Fluid3D([4662,4232,4424,4267],0); -ELEMENTS[20272] = Fluid3D([4043,4195,4232,3779],0); -ELEMENTS[20273] = Fluid3D([4043,4195,3779,3809],0); -ELEMENTS[20274] = Fluid3D([4195,4232,3779,4128],0); -ELEMENTS[20275] = Fluid3D([4195,4232,4128,4700],0); -ELEMENTS[20276] = Fluid3D([3779,4195,4128,3882],0); -ELEMENTS[20277] = Fluid3D([4195,4128,3882,4251],0); -ELEMENTS[20278] = Fluid3D([4232,3779,4128,4110],0); -ELEMENTS[20279] = Fluid3D([4195,4128,4251,4655],0); -ELEMENTS[20280] = Fluid3D([4128,3779,3882,3788],0); -ELEMENTS[20281] = Fluid3D([3882,4195,4251,3809],0); -ELEMENTS[20282] = Fluid3D([3779,4195,3882,3809],0); -ELEMENTS[20283] = Fluid3D([4232,4043,3779,3856],0); -ELEMENTS[20284] = Fluid3D([4232,4043,3856,4361],0); -ELEMENTS[20285] = Fluid3D([4043,3779,3856,3576],0); -ELEMENTS[20286] = Fluid3D([4043,3779,3576,3809],0); -ELEMENTS[20287] = Fluid3D([3856,4043,3576,3875],0); -ELEMENTS[20288] = Fluid3D([3779,4232,3856,3863],0); -ELEMENTS[20289] = Fluid3D([4232,3856,3863,4424],0); -ELEMENTS[20290] = Fluid3D([4043,3576,3875,3958],0); -ELEMENTS[20291] = Fluid3D([3856,4043,3875,4361],0); -ELEMENTS[20292] = Fluid3D([4043,3875,4361,4526],0); -ELEMENTS[20293] = Fluid3D([4361,4043,4526,4580],0); -ELEMENTS[20294] = Fluid3D([4526,4361,4580,5206],0); -ELEMENTS[20295] = Fluid3D([3779,4232,3863,4110],0); -ELEMENTS[20296] = Fluid3D([3576,3856,3875,3499],0); -ELEMENTS[20297] = Fluid3D([3856,3875,3499,3945],0); -ELEMENTS[20298] = Fluid3D([3576,3856,3499,3423],0); -ELEMENTS[20299] = Fluid3D([3875,3499,3945,3669],0); -ELEMENTS[20300] = Fluid3D([3875,3499,3669,3458],0); -ELEMENTS[20301] = Fluid3D([3875,3576,3499,3458],0); -ELEMENTS[20302] = Fluid3D([3856,3875,3945,4361],0); -ELEMENTS[20303] = Fluid3D([3576,3856,3423,3779],0); -ELEMENTS[20304] = Fluid3D([3856,3499,3423,3612],0); -ELEMENTS[20305] = Fluid3D([3856,3499,3612,3945],0); -ELEMENTS[20306] = Fluid3D([3499,3423,3612,3185],0); -ELEMENTS[20307] = Fluid3D([3612,3499,3185,3444],0); -ELEMENTS[20308] = Fluid3D([3612,3499,3444,3945],0); -ELEMENTS[20309] = Fluid3D([3499,3423,3185,3140],0); -ELEMENTS[20310] = Fluid3D([3499,3423,3140,3576],0); -ELEMENTS[20311] = Fluid3D([3423,3185,3140,3018],0); -ELEMENTS[20312] = Fluid3D([3185,3140,3018,2844],0); -ELEMENTS[20313] = Fluid3D([3185,3140,2844,3098],0); -ELEMENTS[20314] = Fluid3D([3185,3140,3098,3499],0); -ELEMENTS[20315] = Fluid3D([3423,3185,3018,3330],0); -ELEMENTS[20316] = Fluid3D([3423,3185,3330,3612],0); -ELEMENTS[20317] = Fluid3D([3185,3018,3330,2914],0); -ELEMENTS[20318] = Fluid3D([3018,3330,2914,2957],0); -ELEMENTS[20319] = Fluid3D([3018,3330,2957,3247],0); -ELEMENTS[20320] = Fluid3D([3018,3330,3247,3423],0); -ELEMENTS[20321] = Fluid3D([3185,3018,2914,2844],0); -ELEMENTS[20322] = Fluid3D([3423,3856,3612,3863],0); -ELEMENTS[20323] = Fluid3D([3185,3612,3444,3319],0); -ELEMENTS[20324] = Fluid3D([3612,3444,3319,3717],0); -ELEMENTS[20325] = Fluid3D([3185,3612,3319,3330],0); -ELEMENTS[20326] = Fluid3D([3444,3185,3319,3053],0); -ELEMENTS[20327] = Fluid3D([3185,3319,3053,2914],0); -ELEMENTS[20328] = Fluid3D([3444,3185,3053,3098],0); -ELEMENTS[20329] = Fluid3D([3612,3444,3717,3945],0); -ELEMENTS[20330] = Fluid3D([3444,3319,3717,3406],0); -ELEMENTS[20331] = Fluid3D([3717,3444,3406,3738],0); -ELEMENTS[20332] = Fluid3D([3444,3319,3406,3053],0); -ELEMENTS[20333] = Fluid3D([3319,3717,3406,3534],0); -ELEMENTS[20334] = Fluid3D([3319,3717,3534,3670],0); -ELEMENTS[20335] = Fluid3D([3319,3717,3670,3612],0); -ELEMENTS[20336] = Fluid3D([3406,3319,3534,3124],0); -ELEMENTS[20337] = Fluid3D([3406,3319,3124,3053],0); -ELEMENTS[20338] = Fluid3D([3319,3534,3124,3246],0); -ELEMENTS[20339] = Fluid3D([3534,3124,3246,3299],0); -ELEMENTS[20340] = Fluid3D([3534,3124,3299,3369],0); -ELEMENTS[20341] = Fluid3D([3534,3124,3369,3406],0); -ELEMENTS[20342] = Fluid3D([3319,3534,3246,3670],0); -ELEMENTS[20343] = Fluid3D([3717,3444,3738,3945],0); -ELEMENTS[20344] = Fluid3D([3444,3406,3738,3308],0); -ELEMENTS[20345] = Fluid3D([3444,3406,3308,3053],0); -ELEMENTS[20346] = Fluid3D([3738,3444,3308,3669],0); -ELEMENTS[20347] = Fluid3D([3406,3738,3308,3519],0); -ELEMENTS[20348] = Fluid3D([3308,3406,3519,3112],0); -ELEMENTS[20349] = Fluid3D([3308,3406,3112,3053],0); -ELEMENTS[20350] = Fluid3D([3406,3738,3519,3801],0); -ELEMENTS[20351] = Fluid3D([3406,3738,3801,3717],0); -ELEMENTS[20352] = Fluid3D([3738,3519,3801,3988],0); -ELEMENTS[20353] = Fluid3D([3519,3801,3988,3808],0); -ELEMENTS[20354] = Fluid3D([3519,3801,3808,3369],0); -ELEMENTS[20355] = Fluid3D([3738,3519,3988,3698],0); -ELEMENTS[20356] = Fluid3D([3738,3519,3698,3308],0); -ELEMENTS[20357] = Fluid3D([3519,3988,3698,3739],0); -ELEMENTS[20358] = Fluid3D([3519,3988,3739,3808],0); -ELEMENTS[20359] = Fluid3D([3988,3698,3739,4102],0); -ELEMENTS[20360] = Fluid3D([3988,3698,4102,4125],0); -ELEMENTS[20361] = Fluid3D([3988,3698,4125,3738],0); -ELEMENTS[20362] = Fluid3D([3739,3988,4102,4480],0); -ELEMENTS[20363] = Fluid3D([3406,3519,3112,3369],0); -ELEMENTS[20364] = Fluid3D([3330,3185,2914,3319],0); -ELEMENTS[20365] = Fluid3D([3698,3519,3739,3339],0); -ELEMENTS[20366] = Fluid3D([3698,3519,3339,3308],0); -ELEMENTS[20367] = Fluid3D([3519,3739,3339,3381],0); -ELEMENTS[20368] = Fluid3D([3519,3739,3381,3808],0); -ELEMENTS[20369] = Fluid3D([3339,3519,3381,3112],0); -ELEMENTS[20370] = Fluid3D([3739,3339,3381,3432],0); -ELEMENTS[20371] = Fluid3D([3381,3739,3432,3692],0); -ELEMENTS[20372] = Fluid3D([3739,3339,3432,3595],0); -ELEMENTS[20373] = Fluid3D([3339,3381,3432,3062],0); -ELEMENTS[20374] = Fluid3D([3381,3432,3062,3233],0); -ELEMENTS[20375] = Fluid3D([3381,3432,3233,3692],0); -ELEMENTS[20376] = Fluid3D([3339,3381,3062,3112],0); -ELEMENTS[20377] = Fluid3D([3381,3739,3692,3808],0); -ELEMENTS[20378] = Fluid3D([3739,3698,3339,3595],0); -ELEMENTS[20379] = Fluid3D([3856,3779,3863,3423],0); -ELEMENTS[20380] = Fluid3D([3499,3185,3444,3098],0); -ELEMENTS[20381] = Fluid3D([3519,3308,3112,3339],0); -ELEMENTS[20382] = Fluid3D([3140,3423,3018,2989],0); -ELEMENTS[20383] = Fluid3D([9501,8610,8663,9257],0); -ELEMENTS[20384] = Fluid3D([6814,6305,6139,5959],0); -ELEMENTS[20385] = Fluid3D([5270,5050,5478,4746],0); -ELEMENTS[20386] = Fluid3D([8396,7984,8170,7368],0); -ELEMENTS[20387] = Fluid3D([7775,8598,8228,8148],0); -ELEMENTS[20388] = Fluid3D([8228,7775,8148,7153],0); -ELEMENTS[20389] = Fluid3D([8598,8228,8148,8910],0); -ELEMENTS[20390] = Fluid3D([8228,8148,8910,7894],0); -ELEMENTS[20391] = Fluid3D([8228,8148,7894,7153],0); -ELEMENTS[20392] = Fluid3D([5461,5720,5115,5280],0); -ELEMENTS[20393] = Fluid3D([5720,5115,5280,5255],0); -ELEMENTS[20394] = Fluid3D([4043,3958,3809,3576],0); -ELEMENTS[20395] = Fluid3D([9224,8598,8610,8367],0); -ELEMENTS[20396] = Fluid3D([6756,7508,6886,7611],0); -ELEMENTS[20397] = Fluid3D([7984,8874,8295,7981],0); -ELEMENTS[20398] = Fluid3D([8295,7984,7981,7467],0); -ELEMENTS[20399] = Fluid3D([9613,8598,9224,9294],0); -ELEMENTS[20400] = Fluid3D([8598,9224,9294,8682],0); -ELEMENTS[20401] = Fluid3D([9224,9294,8682,9549],0); -ELEMENTS[20402] = Fluid3D([9294,8682,9549,8910],0); -ELEMENTS[20403] = Fluid3D([9613,8598,9294,9062],0); -ELEMENTS[20404] = Fluid3D([9224,9613,9294,10194],0); -ELEMENTS[20405] = Fluid3D([9224,9613,10194,10298],0); -ELEMENTS[20406] = Fluid3D([9613,9294,10194,10131],0); -ELEMENTS[20407] = Fluid3D([9294,10194,10131,9549],0); -ELEMENTS[20408] = Fluid3D([9294,9224,10194,9549],0); -ELEMENTS[20409] = Fluid3D([9294,8598,8682,8910],0); -ELEMENTS[20410] = Fluid3D([8598,9224,8682,8367],0); -ELEMENTS[20411] = Fluid3D([8682,9224,9549,8623],0); -ELEMENTS[20412] = Fluid3D([6617,7328,7123,6656],0); -ELEMENTS[20413] = Fluid3D([7293,6738,7090,6917],0); -ELEMENTS[20414] = Fluid3D([6738,7090,6917,5974],0); -ELEMENTS[20415] = Fluid3D([7293,6738,6917,6460],0); -ELEMENTS[20416] = Fluid3D([7090,7293,6917,7545],0); -ELEMENTS[20417] = Fluid3D([7293,6917,7545,7910],0); -ELEMENTS[20418] = Fluid3D([7090,7293,7545,8062],0); -ELEMENTS[20419] = Fluid3D([6917,7090,7545,6838],0); -ELEMENTS[20420] = Fluid3D([7090,7545,6838,8228],0); -ELEMENTS[20421] = Fluid3D([6917,7090,6838,5974],0); -ELEMENTS[20422] = Fluid3D([6738,7467,7090,6885],0); -ELEMENTS[20423] = Fluid3D([7293,7815,7420,8469],0); -ELEMENTS[20424] = Fluid3D([5941,6428,6208,5824],0); -ELEMENTS[20425] = Fluid3D([9224,8610,9501,9257],0); -ELEMENTS[20426] = Fluid3D([7368,7467,6738,6772],0); -ELEMENTS[20427] = Fluid3D([7368,6957,7815,7413],0); -ELEMENTS[20428] = Fluid3D([7118,7508,6756,7374],0); -ELEMENTS[20429] = Fluid3D([6756,7118,7374,6518],0); -ELEMENTS[20430] = Fluid3D([7374,6756,6518,6558],0); -ELEMENTS[20431] = Fluid3D([6756,6518,6558,6165],0); -ELEMENTS[20432] = Fluid3D([6558,6756,6165,6886],0); -ELEMENTS[20433] = Fluid3D([7374,6756,6558,7611],0); -ELEMENTS[20434] = Fluid3D([5158,4699,4669,4386],0); -ELEMENTS[20435] = Fluid3D([6189,6885,6772,6738],0); -ELEMENTS[20436] = Fluid3D([8295,8598,7775,8610],0); -ELEMENTS[20437] = Fluid3D([6617,7123,6815,5948],0); -ELEMENTS[20438] = Fluid3D([4043,4526,3958,3875],0); -ELEMENTS[20439] = Fluid3D([5050,5270,4699,4746],0); -ELEMENTS[20440] = Fluid3D([12511,11603,11921,12254],0); -ELEMENTS[20441] = Fluid3D([10207,11060,10131,11103],0); -ELEMENTS[20442] = Fluid3D([12537,13160,12268,13149],0); -ELEMENTS[20443] = Fluid3D([11929,11060,11359,11103],0); -ELEMENTS[20444] = Fluid3D([11103,11970,11064,11524],0); -ELEMENTS[20445] = Fluid3D([10941,10962,9973,10542],0); -ELEMENTS[20446] = Fluid3D([10131,9756,9286,9294],0); -ELEMENTS[20447] = Fluid3D([11729,10901,10830,11030],0); -ELEMENTS[20448] = Fluid3D([10271,11030,10975,10725],0); -ELEMENTS[20449] = Fluid3D([12896,11970,12127,11981],0); -ELEMENTS[20450] = Fluid3D([2946,2716,2739,2592],0); -ELEMENTS[20451] = Fluid3D([3019,3022,3388,2997],0); -ELEMENTS[20452] = Fluid3D([11612,12545,12350,12581],0); -ELEMENTS[20453] = Fluid3D([8252,8231,8908,8014],0); -ELEMENTS[20454] = Fluid3D([8908,8252,8014,7852],0); -ELEMENTS[20455] = Fluid3D([8252,8231,8014,7260],0); -ELEMENTS[20456] = Fluid3D([8231,8908,8014,8452],0); -ELEMENTS[20457] = Fluid3D([8908,8014,8452,8271],0); -ELEMENTS[20458] = Fluid3D([8014,8452,8271,7584],0); -ELEMENTS[20459] = Fluid3D([8014,8452,7584,8231],0); -ELEMENTS[20460] = Fluid3D([7584,8014,8231,7260],0); -ELEMENTS[20461] = Fluid3D([8271,8014,7584,7485],0); -ELEMENTS[20462] = Fluid3D([8014,7584,7485,7117],0); -ELEMENTS[20463] = Fluid3D([8014,7584,7117,7260],0); -ELEMENTS[20464] = Fluid3D([8231,8908,8452,9444],0); -ELEMENTS[20465] = Fluid3D([7507,7392,8136,7997],0); -ELEMENTS[20466] = Fluid3D([8136,7507,7997,8453],0); -ELEMENTS[20467] = Fluid3D([7507,7392,7997,6998],0); -ELEMENTS[20468] = Fluid3D([7507,7997,8453,7519],0); -ELEMENTS[20469] = Fluid3D([8136,7507,8453,7845],0); -ELEMENTS[20470] = Fluid3D([7997,8136,8453,8869],0); -ELEMENTS[20471] = Fluid3D([7997,8136,8869,8291],0); -ELEMENTS[20472] = Fluid3D([8869,7997,8291,8614],0); -ELEMENTS[20473] = Fluid3D([8136,8453,8869,8955],0); -ELEMENTS[20474] = Fluid3D([8136,8453,8955,7845],0); -ELEMENTS[20475] = Fluid3D([8291,8869,8614,9392],0); -ELEMENTS[20476] = Fluid3D([8869,8136,8955,8947],0); -ELEMENTS[20477] = Fluid3D([8136,8955,8947,8475],0); -ELEMENTS[20478] = Fluid3D([8955,8869,8947,9713],0); -ELEMENTS[20479] = Fluid3D([8955,8869,9713,9411],0); -ELEMENTS[20480] = Fluid3D([9713,8955,9411,9977],0); -ELEMENTS[20481] = Fluid3D([9713,8955,9977,9601],0); -ELEMENTS[20482] = Fluid3D([9713,8955,9601,8947],0); -ELEMENTS[20483] = Fluid3D([8869,8136,8947,8291],0); -ELEMENTS[20484] = Fluid3D([8955,8869,9411,8453],0); -ELEMENTS[20485] = Fluid3D([9977,9713,9601,10539],0); -ELEMENTS[20486] = Fluid3D([9601,9977,10539,10497],0); -ELEMENTS[20487] = Fluid3D([9977,9713,10539,10486],0); -ELEMENTS[20488] = Fluid3D([9977,9713,10486,9411],0); -ELEMENTS[20489] = Fluid3D([9713,9601,10539,9712],0); -ELEMENTS[20490] = Fluid3D([10539,9977,10486,10952],0); -ELEMENTS[20491] = Fluid3D([8947,8136,8475,7712],0); -ELEMENTS[20492] = Fluid3D([9601,9977,10497,9309],0); -ELEMENTS[20493] = Fluid3D([9601,9977,9309,8955],0); -ELEMENTS[20494] = Fluid3D([9977,10497,9309,10044],0); -ELEMENTS[20495] = Fluid3D([9309,9977,10044,9237],0); -ELEMENTS[20496] = Fluid3D([9309,9977,9237,8955],0); -ELEMENTS[20497] = Fluid3D([9977,10497,10044,11213],0); -ELEMENTS[20498] = Fluid3D([10497,9601,9309,9686],0); -ELEMENTS[20499] = Fluid3D([9601,9309,9686,8475],0); -ELEMENTS[20500] = Fluid3D([9309,10497,9686,9884],0); -ELEMENTS[20501] = Fluid3D([10497,9601,9686,10221],0); -ELEMENTS[20502] = Fluid3D([10497,9309,10044,9884],0); -ELEMENTS[20503] = Fluid3D([9977,10044,9237,10223],0); -ELEMENTS[20504] = Fluid3D([10044,9237,10223,9547],0); -ELEMENTS[20505] = Fluid3D([9977,10044,10223,11213],0); -ELEMENTS[20506] = Fluid3D([10223,10044,9547,10517],0); -ELEMENTS[20507] = Fluid3D([10223,10044,10517,11213],0); -ELEMENTS[20508] = Fluid3D([10044,9547,10517,9884],0); -ELEMENTS[20509] = Fluid3D([10044,10517,11213,10497],0); -ELEMENTS[20510] = Fluid3D([8453,7997,8869,8675],0); -ELEMENTS[20511] = Fluid3D([7997,8869,8675,8614],0); -ELEMENTS[20512] = Fluid3D([8453,7997,8675,7519],0); -ELEMENTS[20513] = Fluid3D([8869,8453,8675,9411],0); -ELEMENTS[20514] = Fluid3D([8136,8955,8475,7845],0); -ELEMENTS[20515] = Fluid3D([10539,9601,10497,10221],0); -ELEMENTS[20516] = Fluid3D([8955,9411,9977,9237],0); -ELEMENTS[20517] = Fluid3D([7392,8136,7997,8291],0); -ELEMENTS[20518] = Fluid3D([9713,10539,10486,10487],0); -ELEMENTS[20519] = Fluid3D([10539,10486,10487,11389],0); -ELEMENTS[20520] = Fluid3D([10486,10487,11389,11144],0); -ELEMENTS[20521] = Fluid3D([10486,9713,10487,10020],0); -ELEMENTS[20522] = Fluid3D([9713,10539,10487,9712],0); -ELEMENTS[20523] = Fluid3D([10487,11389,11144,11619],0); -ELEMENTS[20524] = Fluid3D([10487,11389,11619,11308],0); -ELEMENTS[20525] = Fluid3D([11144,10487,11619,10899],0); -ELEMENTS[20526] = Fluid3D([11144,10487,10899,10020],0); -ELEMENTS[20527] = Fluid3D([10487,11389,11308,10539],0); -ELEMENTS[20528] = Fluid3D([11619,11144,10899,11804],0); -ELEMENTS[20529] = Fluid3D([11619,11144,11804,12399],0); -ELEMENTS[20530] = Fluid3D([11144,10899,11804,11472],0); -ELEMENTS[20531] = Fluid3D([11804,11144,11472,12399],0); -ELEMENTS[20532] = Fluid3D([11472,11804,12399,12197],0); -ELEMENTS[20533] = Fluid3D([11804,12399,12197,12357],0); -ELEMENTS[20534] = Fluid3D([11804,12399,12357,11619],0); -ELEMENTS[20535] = Fluid3D([10486,9713,10020,9411],0); -ELEMENTS[20536] = Fluid3D([11389,11144,11619,11684],0); -ELEMENTS[20537] = Fluid3D([11389,11144,11684,10486],0); -ELEMENTS[20538] = Fluid3D([10486,10487,11144,10020],0); -ELEMENTS[20539] = Fluid3D([10539,10486,11389,10952],0); -ELEMENTS[20540] = Fluid3D([11619,10487,11308,10398],0); -ELEMENTS[20541] = Fluid3D([9713,10487,10020,9392],0); -ELEMENTS[20542] = Fluid3D([10899,11619,11804,11383],0); -ELEMENTS[20543] = Fluid3D([11804,10899,11383,11031],0); -ELEMENTS[20544] = Fluid3D([10899,11383,11031,10436],0); -ELEMENTS[20545] = Fluid3D([10899,11383,10436,10791],0); -ELEMENTS[20546] = Fluid3D([10899,11383,10791,11619],0); -ELEMENTS[20547] = Fluid3D([11383,11031,10436,11189],0); -ELEMENTS[20548] = Fluid3D([11383,10436,10791,11171],0); -ELEMENTS[20549] = Fluid3D([10791,11383,11171,11878],0); -ELEMENTS[20550] = Fluid3D([11171,10791,11878,11562],0); -ELEMENTS[20551] = Fluid3D([10436,10899,10791,10398],0); -ELEMENTS[20552] = Fluid3D([10899,10791,10398,11619],0); -ELEMENTS[20553] = Fluid3D([11031,10899,10436,10091],0); -ELEMENTS[20554] = Fluid3D([11383,11804,11031,11935],0); -ELEMENTS[20555] = Fluid3D([11031,11383,11935,11189],0); -ELEMENTS[20556] = Fluid3D([10899,10436,10091,10398],0); -ELEMENTS[20557] = Fluid3D([11383,11804,11935,12357],0); -ELEMENTS[20558] = Fluid3D([11804,11935,12357,12197],0); -ELEMENTS[20559] = Fluid3D([11383,11804,12357,11619],0); -ELEMENTS[20560] = Fluid3D([11804,11935,12197,11031],0); -ELEMENTS[20561] = Fluid3D([11935,11383,12357,11945],0); -ELEMENTS[20562] = Fluid3D([11031,10899,10091,11472],0); -ELEMENTS[20563] = Fluid3D([11804,10899,11031,11472],0); -ELEMENTS[20564] = Fluid3D([10436,11031,10091,10297],0); -ELEMENTS[20565] = Fluid3D([10091,10436,10297,9439],0); -ELEMENTS[20566] = Fluid3D([10091,10436,9439,9392],0); -ELEMENTS[20567] = Fluid3D([11031,10091,10297,10438],0); -ELEMENTS[20568] = Fluid3D([11031,10091,10438,11472],0); -ELEMENTS[20569] = Fluid3D([10297,10091,9439,9383],0); -ELEMENTS[20570] = Fluid3D([10091,10297,10438,9383],0); -ELEMENTS[20571] = Fluid3D([10091,9439,9383,8614],0); -ELEMENTS[20572] = Fluid3D([10436,10297,9439,9933],0); -ELEMENTS[20573] = Fluid3D([9439,10436,9933,9723],0); -ELEMENTS[20574] = Fluid3D([10436,10297,9933,11189],0); -ELEMENTS[20575] = Fluid3D([9933,9439,9723,8999],0); -ELEMENTS[20576] = Fluid3D([9439,9723,8999,8858],0); -ELEMENTS[20577] = Fluid3D([9439,9723,8858,9392],0); -ELEMENTS[20578] = Fluid3D([10436,11031,10297,11189],0); -ELEMENTS[20579] = Fluid3D([9933,9439,8999,9202],0); -ELEMENTS[20580] = Fluid3D([9933,9439,9202,10297],0); -ELEMENTS[20581] = Fluid3D([9439,8999,9202,8507],0); -ELEMENTS[20582] = Fluid3D([8999,9933,9202,9293],0); -ELEMENTS[20583] = Fluid3D([8999,9202,8507,8372],0); -ELEMENTS[20584] = Fluid3D([8999,9933,9293,9620],0); -ELEMENTS[20585] = Fluid3D([8999,9933,9620,9723],0); -ELEMENTS[20586] = Fluid3D([9933,9293,9620,10755],0); -ELEMENTS[20587] = Fluid3D([8999,9202,8372,9293],0); -ELEMENTS[20588] = Fluid3D([10297,11031,10438,11270],0); -ELEMENTS[20589] = Fluid3D([11031,10438,11270,11472],0); -ELEMENTS[20590] = Fluid3D([9439,8999,8507,8858],0); -ELEMENTS[20591] = Fluid3D([9933,9202,9293,9980],0); -ELEMENTS[20592] = Fluid3D([9933,9202,9980,10297],0); -ELEMENTS[20593] = Fluid3D([9202,9293,9980,9064],0); -ELEMENTS[20594] = Fluid3D([9980,9202,9064,9534],0); -ELEMENTS[20595] = Fluid3D([9980,9202,9534,10297],0); -ELEMENTS[20596] = Fluid3D([9202,9293,9064,8372],0); -ELEMENTS[20597] = Fluid3D([9293,9933,9980,10755],0); -ELEMENTS[20598] = Fluid3D([9064,9980,9534,9920],0); -ELEMENTS[20599] = Fluid3D([9980,9534,9920,10675],0); -ELEMENTS[20600] = Fluid3D([9064,9980,9920,9690],0); -ELEMENTS[20601] = Fluid3D([9534,9064,9920,9005],0); -ELEMENTS[20602] = Fluid3D([9920,9534,9005,10139],0); -ELEMENTS[20603] = Fluid3D([9534,9064,9005,8438],0); -ELEMENTS[20604] = Fluid3D([9064,9920,9005,9090],0); -ELEMENTS[20605] = Fluid3D([9534,9064,8438,9202],0); -ELEMENTS[20606] = Fluid3D([9064,9920,9090,9690],0); -ELEMENTS[20607] = Fluid3D([9064,9005,8438,8223],0); -ELEMENTS[20608] = Fluid3D([8438,9064,8223,8372],0); -ELEMENTS[20609] = Fluid3D([9005,8438,8223,8141],0); -ELEMENTS[20610] = Fluid3D([9005,8438,8141,8906],0); -ELEMENTS[20611] = Fluid3D([9005,8438,8906,9534],0); -ELEMENTS[20612] = Fluid3D([8438,8223,8141,7665],0); -ELEMENTS[20613] = Fluid3D([8438,8223,7665,8372],0); -ELEMENTS[20614] = Fluid3D([9064,9005,8223,9090],0); -ELEMENTS[20615] = Fluid3D([8223,8141,7665,7494],0); -ELEMENTS[20616] = Fluid3D([7665,8223,7494,7454],0); -ELEMENTS[20617] = Fluid3D([7665,8223,7454,8372],0); -ELEMENTS[20618] = Fluid3D([8141,7665,7494,7211],0); -ELEMENTS[20619] = Fluid3D([8223,8141,7494,8258],0); -ELEMENTS[20620] = Fluid3D([7665,7494,7211,6887],0); -ELEMENTS[20621] = Fluid3D([7665,7494,6887,7454],0); -ELEMENTS[20622] = Fluid3D([8141,7494,8258,7679],0); -ELEMENTS[20623] = Fluid3D([7494,8258,7679,7499],0); -ELEMENTS[20624] = Fluid3D([7494,8258,7499,7778],0); -ELEMENTS[20625] = Fluid3D([7494,8258,7778,8223],0); -ELEMENTS[20626] = Fluid3D([8141,7494,7679,7211],0); -ELEMENTS[20627] = Fluid3D([8141,7665,7211,7919],0); -ELEMENTS[20628] = Fluid3D([8141,7665,7919,8438],0); -ELEMENTS[20629] = Fluid3D([7211,8141,7919,7920],0); -ELEMENTS[20630] = Fluid3D([7211,8141,7920,7679],0); -ELEMENTS[20631] = Fluid3D([8223,8141,8258,9005],0); -ELEMENTS[20632] = Fluid3D([7919,7211,7920,7286],0); -ELEMENTS[20633] = Fluid3D([7919,7211,7286,6952],0); -ELEMENTS[20634] = Fluid3D([7211,7920,7286,7068],0); -ELEMENTS[20635] = Fluid3D([7920,7286,7068,7700],0); -ELEMENTS[20636] = Fluid3D([7068,7920,7700,7679],0); -ELEMENTS[20637] = Fluid3D([7211,7920,7068,7679],0); -ELEMENTS[20638] = Fluid3D([7286,7211,7068,6652],0); -ELEMENTS[20639] = Fluid3D([7286,7211,6652,6952],0); -ELEMENTS[20640] = Fluid3D([9293,9980,9064,9690],0); -ELEMENTS[20641] = Fluid3D([9534,9920,10675,10139],0); -ELEMENTS[20642] = Fluid3D([8258,7679,7499,8144],0); -ELEMENTS[20643] = Fluid3D([8258,7679,8144,8390],0); -ELEMENTS[20644] = Fluid3D([7499,8258,8144,8230],0); -ELEMENTS[20645] = Fluid3D([7499,8258,8230,7778],0); -ELEMENTS[20646] = Fluid3D([8144,7499,8230,7674],0); -ELEMENTS[20647] = Fluid3D([7499,8230,7674,7460],0); -ELEMENTS[20648] = Fluid3D([7679,7499,8144,7302],0); -ELEMENTS[20649] = Fluid3D([8230,7674,7460,8091],0); -ELEMENTS[20650] = Fluid3D([8230,7674,8091,8548],0); -ELEMENTS[20651] = Fluid3D([8230,7674,8548,8144],0); -ELEMENTS[20652] = Fluid3D([7679,7499,7302,6720],0); -ELEMENTS[20653] = Fluid3D([7302,7679,6720,7013],0); -ELEMENTS[20654] = Fluid3D([7302,7679,7013,7592],0); -ELEMENTS[20655] = Fluid3D([7013,7302,7592,6827],0); -ELEMENTS[20656] = Fluid3D([7679,7499,6720,7494],0); -ELEMENTS[20657] = Fluid3D([7499,8230,7460,7778],0); -ELEMENTS[20658] = Fluid3D([8144,7499,7674,7302],0); -ELEMENTS[20659] = Fluid3D([7674,8091,8548,7977],0); -ELEMENTS[20660] = Fluid3D([7674,8091,7977,7221],0); -ELEMENTS[20661] = Fluid3D([8091,8548,7977,8778],0); -ELEMENTS[20662] = Fluid3D([8091,8548,8778,9004],0); -ELEMENTS[20663] = Fluid3D([8091,8548,9004,8230],0); -ELEMENTS[20664] = Fluid3D([7977,8091,8778,7935],0); -ELEMENTS[20665] = Fluid3D([8778,7977,7935,8967],0); -ELEMENTS[20666] = Fluid3D([8548,7674,7977,8186],0); -ELEMENTS[20667] = Fluid3D([8548,7977,8778,8967],0); -ELEMENTS[20668] = Fluid3D([8778,8091,9004,8670],0); -ELEMENTS[20669] = Fluid3D([8091,9004,8670,8415],0); -ELEMENTS[20670] = Fluid3D([8778,8091,8670,7514],0); -ELEMENTS[20671] = Fluid3D([9004,8670,8415,9310],0); -ELEMENTS[20672] = Fluid3D([9004,8670,9310,9611],0); -ELEMENTS[20673] = Fluid3D([9004,8670,9611,8778],0); -ELEMENTS[20674] = Fluid3D([8670,8415,9310,8302],0); -ELEMENTS[20675] = Fluid3D([8091,9004,8415,8230],0); -ELEMENTS[20676] = Fluid3D([8670,8091,8415,7750],0); -ELEMENTS[20677] = Fluid3D([8670,8091,7750,7514],0); -ELEMENTS[20678] = Fluid3D([8091,8415,7750,7460],0); -ELEMENTS[20679] = Fluid3D([8415,8670,7750,8302],0); -ELEMENTS[20680] = Fluid3D([8258,8144,8230,8995],0); -ELEMENTS[20681] = Fluid3D([8258,8144,8995,9122],0); -ELEMENTS[20682] = Fluid3D([8230,8258,8995,9090],0); -ELEMENTS[20683] = Fluid3D([8144,8230,8995,8548],0); -ELEMENTS[20684] = Fluid3D([7674,7499,7460,6853],0); -ELEMENTS[20685] = Fluid3D([7674,7499,6853,7302],0); -ELEMENTS[20686] = Fluid3D([7499,7460,6853,6916],0); -ELEMENTS[20687] = Fluid3D([7499,7460,6916,7778],0); -ELEMENTS[20688] = Fluid3D([7460,6853,6916,6616],0); -ELEMENTS[20689] = Fluid3D([6916,7460,6616,7107],0); -ELEMENTS[20690] = Fluid3D([7460,7674,6853,7141],0); -ELEMENTS[20691] = Fluid3D([7460,6853,6616,7141],0); -ELEMENTS[20692] = Fluid3D([7460,7674,7141,8091],0); -ELEMENTS[20693] = Fluid3D([6916,7460,7107,7778],0); -ELEMENTS[20694] = Fluid3D([6616,6916,7107,5997],0); -ELEMENTS[20695] = Fluid3D([6853,6916,6616,6109],0); -ELEMENTS[20696] = Fluid3D([6853,6916,6109,6720],0); -ELEMENTS[20697] = Fluid3D([6916,6616,6109,5997],0); -ELEMENTS[20698] = Fluid3D([6616,6853,6109,6281],0); -ELEMENTS[20699] = Fluid3D([6853,7499,6916,6720],0); -ELEMENTS[20700] = Fluid3D([7460,6616,7107,7278],0); -ELEMENTS[20701] = Fluid3D([7460,6616,7278,7141],0); -ELEMENTS[20702] = Fluid3D([7107,7460,7278,8415],0); -ELEMENTS[20703] = Fluid3D([6616,7107,7278,6566],0); -ELEMENTS[20704] = Fluid3D([7278,6616,6566,6670],0); -ELEMENTS[20705] = Fluid3D([6616,7107,6566,5997],0); -ELEMENTS[20706] = Fluid3D([7107,7278,6566,7364],0); -ELEMENTS[20707] = Fluid3D([6566,7107,7364,6523],0); -ELEMENTS[20708] = Fluid3D([6566,7107,6523,5997],0); -ELEMENTS[20709] = Fluid3D([6523,6566,5997,5844],0); -ELEMENTS[20710] = Fluid3D([7107,7278,7364,8415],0); -ELEMENTS[20711] = Fluid3D([7278,6566,7364,7082],0); -ELEMENTS[20712] = Fluid3D([7499,7302,6720,6853],0); -ELEMENTS[20713] = Fluid3D([9980,9534,10675,10297],0); -ELEMENTS[20714] = Fluid3D([8438,8141,8906,7919],0); -ELEMENTS[20715] = Fluid3D([9439,10297,9383,9202],0); -ELEMENTS[20716] = Fluid3D([9723,8999,8858,9385],0); -ELEMENTS[20717] = Fluid3D([9723,8999,9385,9620],0); -ELEMENTS[20718] = Fluid3D([9385,9723,9620,10855],0); -ELEMENTS[20719] = Fluid3D([8999,9385,9620,8692],0); -ELEMENTS[20720] = Fluid3D([9385,9620,8692,9190],0); -ELEMENTS[20721] = Fluid3D([9385,9620,9190,9965],0); -ELEMENTS[20722] = Fluid3D([8858,9723,9385,9177],0); -ELEMENTS[20723] = Fluid3D([7494,7211,6887,6720],0); -ELEMENTS[20724] = Fluid3D([9439,10436,9723,9392],0); -ELEMENTS[20725] = Fluid3D([9920,9005,9090,9457],0); -ELEMENTS[20726] = Fluid3D([9920,9005,9457,10139],0); -ELEMENTS[20727] = Fluid3D([9090,9920,9457,10304],0); -ELEMENTS[20728] = Fluid3D([9005,9090,9457,8258],0); -ELEMENTS[20729] = Fluid3D([9310,9004,9611,10437],0); -ELEMENTS[20730] = Fluid3D([10436,9933,9723,10615],0); -ELEMENTS[20731] = Fluid3D([10436,9933,10615,11189],0); -ELEMENTS[20732] = Fluid3D([9933,10615,11189,10755],0); -ELEMENTS[20733] = Fluid3D([9723,10436,10615,11171],0); -ELEMENTS[20734] = Fluid3D([9933,9723,10615,9620],0); -ELEMENTS[20735] = Fluid3D([9202,8507,8372,8438],0); -ELEMENTS[20736] = Fluid3D([8144,7679,7302,8285],0); -ELEMENTS[20737] = Fluid3D([9202,9439,8507,9383],0); -ELEMENTS[20738] = Fluid3D([8258,8141,7679,8390],0); -ELEMENTS[20739] = Fluid3D([7920,7919,7286,7816],0); -ELEMENTS[20740] = Fluid3D([11389,11619,11308,12208],0); -ELEMENTS[20741] = Fluid3D([11389,11619,12208,12604],0); -ELEMENTS[20742] = Fluid3D([11308,11389,12208,11658],0); -ELEMENTS[20743] = Fluid3D([11308,11389,11658,10539],0); -ELEMENTS[20744] = Fluid3D([12208,11308,11658,12058],0); -ELEMENTS[20745] = Fluid3D([11308,11658,12058,11184],0); -ELEMENTS[20746] = Fluid3D([11619,11308,12208,11821],0); -ELEMENTS[20747] = Fluid3D([11658,12208,12058,12636],0); -ELEMENTS[20748] = Fluid3D([11658,12208,12636,12842],0); -ELEMENTS[20749] = Fluid3D([12058,11658,12636,12048],0); -ELEMENTS[20750] = Fluid3D([12208,12058,12636,12929],0); -ELEMENTS[20751] = Fluid3D([12636,12208,12929,13497],0); -ELEMENTS[20752] = Fluid3D([12636,12058,12048,13017],0); -ELEMENTS[20753] = Fluid3D([12208,12058,12929,11821],0); -ELEMENTS[20754] = Fluid3D([12058,11658,12048,11184],0); -ELEMENTS[20755] = Fluid3D([12058,12636,12929,13017],0); -ELEMENTS[20756] = Fluid3D([11658,12636,12048,12172],0); -ELEMENTS[20757] = Fluid3D([11389,12208,11658,11910],0); -ELEMENTS[20758] = Fluid3D([12208,11308,12058,11821],0); -ELEMENTS[20759] = Fluid3D([8415,9004,9310,9139],0); -ELEMENTS[20760] = Fluid3D([9004,9310,9139,10437],0); -ELEMENTS[20761] = Fluid3D([8415,9004,9139,8230],0); -ELEMENTS[20762] = Fluid3D([9310,8415,9139,8918],0); -ELEMENTS[20763] = Fluid3D([8415,9139,8918,8334],0); -ELEMENTS[20764] = Fluid3D([9139,9310,8918,10316],0); -ELEMENTS[20765] = Fluid3D([9139,8918,8334,9187],0); -ELEMENTS[20766] = Fluid3D([9139,8918,9187,10316],0); -ELEMENTS[20767] = Fluid3D([8334,9139,9187,9090],0); -ELEMENTS[20768] = Fluid3D([9310,8415,8918,8302],0); -ELEMENTS[20769] = Fluid3D([8918,8334,9187,8488],0); -ELEMENTS[20770] = Fluid3D([8334,9187,8488,8439],0); -ELEMENTS[20771] = Fluid3D([9187,8488,8439,8891],0); -ELEMENTS[20772] = Fluid3D([9187,8918,8488,9398],0); -ELEMENTS[20773] = Fluid3D([8488,9187,9398,9636],0); -ELEMENTS[20774] = Fluid3D([9187,8918,9398,10316],0); -ELEMENTS[20775] = Fluid3D([8918,8334,8488,7995],0); -ELEMENTS[20776] = Fluid3D([8918,8334,7995,8415],0); -ELEMENTS[20777] = Fluid3D([8488,8918,7995,8574],0); -ELEMENTS[20778] = Fluid3D([8334,8488,7995,7662],0); -ELEMENTS[20779] = Fluid3D([8488,7995,7662,7917],0); -ELEMENTS[20780] = Fluid3D([8334,8488,7662,8439],0); -ELEMENTS[20781] = Fluid3D([8918,8488,9398,8574],0); -ELEMENTS[20782] = Fluid3D([7995,8334,7662,7107],0); -ELEMENTS[20783] = Fluid3D([8334,9187,8439,9090],0); -ELEMENTS[20784] = Fluid3D([8415,9139,8334,8230],0); -ELEMENTS[20785] = Fluid3D([9293,8999,9620,8692],0); -ELEMENTS[20786] = Fluid3D([8141,7919,7920,8906],0); -ELEMENTS[20787] = Fluid3D([7679,6720,7013,7211],0); -ELEMENTS[20788] = Fluid3D([9920,9980,10675,10738],0); -ELEMENTS[20789] = Fluid3D([9920,9980,10738,9690],0); -ELEMENTS[20790] = Fluid3D([9980,10675,10738,10819],0); -ELEMENTS[20791] = Fluid3D([10738,9980,10819,9690],0); -ELEMENTS[20792] = Fluid3D([10675,9920,10738,10947],0); -ELEMENTS[20793] = Fluid3D([10675,10738,10819,11581],0); -ELEMENTS[20794] = Fluid3D([10738,10819,11581,11099],0); -ELEMENTS[20795] = Fluid3D([10738,10819,11099,9690],0); -ELEMENTS[20796] = Fluid3D([11581,10738,11099,11345],0); -ELEMENTS[20797] = Fluid3D([11581,10738,11345,11404],0); -ELEMENTS[20798] = Fluid3D([11581,10738,11404,10675],0); -ELEMENTS[20799] = Fluid3D([10738,11099,11345,10404],0); -ELEMENTS[20800] = Fluid3D([10738,11099,10404,9690],0); -ELEMENTS[20801] = Fluid3D([10738,11345,11404,10653],0); -ELEMENTS[20802] = Fluid3D([11345,10738,10404,10653],0); -ELEMENTS[20803] = Fluid3D([11404,10738,10653,10947],0); -ELEMENTS[20804] = Fluid3D([10653,11404,10947,11740],0); -ELEMENTS[20805] = Fluid3D([11404,10947,11740,11867],0); -ELEMENTS[20806] = Fluid3D([11404,10947,11867,10675],0); -ELEMENTS[20807] = Fluid3D([11740,11404,11867,12638],0); -ELEMENTS[20808] = Fluid3D([11345,11581,11404,12638],0); -ELEMENTS[20809] = Fluid3D([11099,11581,11345,12113],0); -ELEMENTS[20810] = Fluid3D([11099,11345,10404,10829],0); -ELEMENTS[20811] = Fluid3D([11345,11404,10653,11740],0); -ELEMENTS[20812] = Fluid3D([10738,10404,10653,9920],0); -ELEMENTS[20813] = Fluid3D([10653,10738,9920,10947],0); -ELEMENTS[20814] = Fluid3D([8548,8778,9004,9814],0); -ELEMENTS[20815] = Fluid3D([8869,8947,9713,9392],0); -ELEMENTS[20816] = Fluid3D([8141,9005,8906,9233],0); -ELEMENTS[20817] = Fluid3D([9977,10539,10497,11052],0); -ELEMENTS[20818] = Fluid3D([9977,10539,11052,10952],0); -ELEMENTS[20819] = Fluid3D([10539,10497,11052,11658],0); -ELEMENTS[20820] = Fluid3D([10497,9977,11052,11213],0); -ELEMENTS[20821] = Fluid3D([11052,10497,11213,11658],0); -ELEMENTS[20822] = Fluid3D([7211,7665,6887,6952],0); -ELEMENTS[20823] = Fluid3D([10487,11619,10899,10398],0); -ELEMENTS[20824] = Fluid3D([10899,10487,10398,10020],0); -ELEMENTS[20825] = Fluid3D([8955,8947,8475,9601],0); -ELEMENTS[20826] = Fluid3D([8223,7494,7454,7778],0); -ELEMENTS[20827] = Fluid3D([10044,9309,9237,9547],0); -ELEMENTS[20828] = Fluid3D([8507,8999,8372,8068],0); -ELEMENTS[20829] = Fluid3D([8507,8999,8068,8858],0); -ELEMENTS[20830] = Fluid3D([8999,8372,8068,8692],0); -ELEMENTS[20831] = Fluid3D([8372,8507,8068,7181],0); -ELEMENTS[20832] = Fluid3D([7997,8291,8614,7745],0); -ELEMENTS[20833] = Fluid3D([7997,8291,7745,7392],0); -ELEMENTS[20834] = Fluid3D([8614,7997,7745,7856],0); -ELEMENTS[20835] = Fluid3D([8291,8614,7745,8858],0); -ELEMENTS[20836] = Fluid3D([7665,7211,7919,6952],0); -ELEMENTS[20837] = Fluid3D([8869,9713,9411,10020],0); -ELEMENTS[20838] = Fluid3D([7499,7494,7778,6916],0); -ELEMENTS[20839] = Fluid3D([6720,7302,7013,6466],0); -ELEMENTS[20840] = Fluid3D([7302,7013,6466,6827],0); -ELEMENTS[20841] = Fluid3D([6720,7302,6466,6853],0); -ELEMENTS[20842] = Fluid3D([7013,6720,6466,6249],0); -ELEMENTS[20843] = Fluid3D([6466,7013,6249,6403],0); -ELEMENTS[20844] = Fluid3D([7013,6249,6403,7068],0); -ELEMENTS[20845] = Fluid3D([7013,6249,7068,6501],0); -ELEMENTS[20846] = Fluid3D([7013,6249,6501,6720],0); -ELEMENTS[20847] = Fluid3D([6249,6501,6720,5944],0); -ELEMENTS[20848] = Fluid3D([6249,6501,5944,6062],0); -ELEMENTS[20849] = Fluid3D([6501,7013,6720,7211],0); -ELEMENTS[20850] = Fluid3D([6720,6501,7211,6887],0); -ELEMENTS[20851] = Fluid3D([6249,7068,6501,6238],0); -ELEMENTS[20852] = Fluid3D([6501,6249,6238,6062],0); -ELEMENTS[20853] = Fluid3D([6501,6720,5944,6179],0); -ELEMENTS[20854] = Fluid3D([7068,7013,6501,7211],0); -ELEMENTS[20855] = Fluid3D([6720,6501,6887,6179],0); -ELEMENTS[20856] = Fluid3D([6466,7013,6403,6827],0); -ELEMENTS[20857] = Fluid3D([6249,6466,6403,5827],0); -ELEMENTS[20858] = Fluid3D([6249,6466,5827,5944],0); -ELEMENTS[20859] = Fluid3D([5827,6249,5944,5681],0); -ELEMENTS[20860] = Fluid3D([5944,5827,5681,5297],0); -ELEMENTS[20861] = Fluid3D([5944,5827,5297,5363],0); -ELEMENTS[20862] = Fluid3D([6249,5944,5681,6062],0); -ELEMENTS[20863] = Fluid3D([5681,5944,5297,5474],0); -ELEMENTS[20864] = Fluid3D([5827,5681,5297,5321],0); -ELEMENTS[20865] = Fluid3D([5297,5827,5321,5114],0); -ELEMENTS[20866] = Fluid3D([5321,5297,5114,4565],0); -ELEMENTS[20867] = Fluid3D([5827,5321,5114,5593],0); -ELEMENTS[20868] = Fluid3D([5321,5114,5593,4873],0); -ELEMENTS[20869] = Fluid3D([5827,6249,5681,6065],0); -ELEMENTS[20870] = Fluid3D([5827,5681,5321,6065],0); -ELEMENTS[20871] = Fluid3D([6249,5681,6065,6238],0); -ELEMENTS[20872] = Fluid3D([5827,5321,5593,6065],0); -ELEMENTS[20873] = Fluid3D([5827,5297,5363,5114],0); -ELEMENTS[20874] = Fluid3D([5297,5363,5114,4784],0); -ELEMENTS[20875] = Fluid3D([5297,5363,4784,5552],0); -ELEMENTS[20876] = Fluid3D([5114,5297,4784,4565],0); -ELEMENTS[20877] = Fluid3D([5297,5363,5552,5944],0); -ELEMENTS[20878] = Fluid3D([5681,5297,5321,5040],0); -ELEMENTS[20879] = Fluid3D([5297,5321,5040,4565],0); -ELEMENTS[20880] = Fluid3D([5681,5297,5040,5474],0); -ELEMENTS[20881] = Fluid3D([5827,6249,6065,6403],0); -ELEMENTS[20882] = Fluid3D([6065,5827,6403,5593],0); -ELEMENTS[20883] = Fluid3D([6249,6065,6403,7068],0); -ELEMENTS[20884] = Fluid3D([5321,5681,5040,5388],0); -ELEMENTS[20885] = Fluid3D([5040,5321,5388,4842],0); -ELEMENTS[20886] = Fluid3D([5388,5040,4842,4862],0); -ELEMENTS[20887] = Fluid3D([5388,5040,4862,5355],0); -ELEMENTS[20888] = Fluid3D([5388,5040,5355,5681],0); -ELEMENTS[20889] = Fluid3D([4862,5388,5355,5366],0); -ELEMENTS[20890] = Fluid3D([4862,5388,5366,5057],0); -ELEMENTS[20891] = Fluid3D([4862,5388,5057,4842],0); -ELEMENTS[20892] = Fluid3D([5355,4862,5366,5064],0); -ELEMENTS[20893] = Fluid3D([5355,4862,5064,4783],0); -ELEMENTS[20894] = Fluid3D([5064,5355,4783,4830],0); -ELEMENTS[20895] = Fluid3D([4783,5064,4830,4436],0); -ELEMENTS[20896] = Fluid3D([4830,4783,4436,4352],0); -ELEMENTS[20897] = Fluid3D([4783,5064,4436,4862],0); -ELEMENTS[20898] = Fluid3D([4862,5366,5064,4802],0); -ELEMENTS[20899] = Fluid3D([5064,4862,4802,4436],0); -ELEMENTS[20900] = Fluid3D([6466,6403,5827,5707],0); -ELEMENTS[20901] = Fluid3D([5355,4862,4783,5040],0); -ELEMENTS[20902] = Fluid3D([4862,5366,4802,5057],0); -ELEMENTS[20903] = Fluid3D([5040,5321,4842,4565],0); -ELEMENTS[20904] = Fluid3D([5321,5681,5388,6065],0); -ELEMENTS[20905] = Fluid3D([5366,5355,5064,5784],0); -ELEMENTS[20906] = Fluid3D([5040,4842,4862,4460],0); -ELEMENTS[20907] = Fluid3D([5040,4842,4460,4565],0); -ELEMENTS[20908] = Fluid3D([4842,4460,4565,4353],0); -ELEMENTS[20909] = Fluid3D([4862,5040,4460,4783],0); -ELEMENTS[20910] = Fluid3D([4842,4862,4460,4423],0); -ELEMENTS[20911] = Fluid3D([4460,4842,4423,4353],0); -ELEMENTS[20912] = Fluid3D([4842,4862,4423,5057],0); -ELEMENTS[20913] = Fluid3D([4862,4460,4423,4253],0); -ELEMENTS[20914] = Fluid3D([4460,4423,4253,4054],0); -ELEMENTS[20915] = Fluid3D([4460,4423,4054,4353],0); -ELEMENTS[20916] = Fluid3D([4423,4862,4253,4802],0); -ELEMENTS[20917] = Fluid3D([4862,4460,4253,4783],0); -ELEMENTS[20918] = Fluid3D([5388,5355,5366,5784],0); -ELEMENTS[20919] = Fluid3D([5388,5366,5057,5702],0); -ELEMENTS[20920] = Fluid3D([5388,5366,5702,5935],0); -ELEMENTS[20921] = Fluid3D([5057,5388,5702,5379],0); -ELEMENTS[20922] = Fluid3D([5057,5388,5379,4842],0); -ELEMENTS[20923] = Fluid3D([5366,5702,5935,6029],0); -ELEMENTS[20924] = Fluid3D([5935,5366,6029,5784],0); -ELEMENTS[20925] = Fluid3D([5366,5702,6029,5414],0); -ELEMENTS[20926] = Fluid3D([5366,5702,5414,5057],0); -ELEMENTS[20927] = Fluid3D([5702,6029,5414,5920],0); -ELEMENTS[20928] = Fluid3D([5702,5935,6029,6420],0); -ELEMENTS[20929] = Fluid3D([5388,5366,5935,5784],0); -ELEMENTS[20930] = Fluid3D([5388,5702,5379,6065],0); -ELEMENTS[20931] = Fluid3D([5702,5388,5935,6065],0); -ELEMENTS[20932] = Fluid3D([6029,5366,5414,5511],0); -ELEMENTS[20933] = Fluid3D([6029,5366,5511,5784],0); -ELEMENTS[20934] = Fluid3D([5366,5414,5511,4802],0); -ELEMENTS[20935] = Fluid3D([5414,6029,5511,5856],0); -ELEMENTS[20936] = Fluid3D([6029,5511,5856,6105],0); -ELEMENTS[20937] = Fluid3D([5511,5414,5856,5218],0); -ELEMENTS[20938] = Fluid3D([5511,5856,6105,5679],0); -ELEMENTS[20939] = Fluid3D([5414,6029,5856,5920],0); -ELEMENTS[20940] = Fluid3D([5856,5511,5218,5679],0); -ELEMENTS[20941] = Fluid3D([6029,5511,6105,5687],0); -ELEMENTS[20942] = Fluid3D([6029,5511,5687,5784],0); -ELEMENTS[20943] = Fluid3D([5511,6105,5687,5648],0); -ELEMENTS[20944] = Fluid3D([6105,6029,5687,6492],0); -ELEMENTS[20945] = Fluid3D([6105,5687,5648,6657],0); -ELEMENTS[20946] = Fluid3D([5687,6105,6492,6657],0); -ELEMENTS[20947] = Fluid3D([5511,6105,5648,5679],0); -ELEMENTS[20948] = Fluid3D([6105,6029,6492,6576],0); -ELEMENTS[20949] = Fluid3D([6105,6029,6576,5856],0); -ELEMENTS[20950] = Fluid3D([6029,6492,6576,6525],0); -ELEMENTS[20951] = Fluid3D([6029,6492,6525,5935],0); -ELEMENTS[20952] = Fluid3D([6576,6029,6525,6573],0); -ELEMENTS[20953] = Fluid3D([6525,6576,6573,7187],0); -ELEMENTS[20954] = Fluid3D([6576,6573,7187,7361],0); -ELEMENTS[20955] = Fluid3D([6576,6573,7361,6769],0); -ELEMENTS[20956] = Fluid3D([6525,6576,7187,6492],0); -ELEMENTS[20957] = Fluid3D([6576,6029,6573,5856],0); -ELEMENTS[20958] = Fluid3D([6573,6576,5856,6769],0); -ELEMENTS[20959] = Fluid3D([6492,6105,6576,6657],0); -ELEMENTS[20960] = Fluid3D([5511,5414,5218,4802],0); -ELEMENTS[20961] = Fluid3D([5687,5511,5648,5196],0); -ELEMENTS[20962] = Fluid3D([5687,5511,5196,5064],0); -ELEMENTS[20963] = Fluid3D([5196,5687,5064,5285],0); -ELEMENTS[20964] = Fluid3D([5064,5196,5285,4755],0); -ELEMENTS[20965] = Fluid3D([5064,5196,4755,4772],0); -ELEMENTS[20966] = Fluid3D([5064,5196,4772,5511],0); -ELEMENTS[20967] = Fluid3D([5196,5285,4755,5265],0); -ELEMENTS[20968] = Fluid3D([5196,5285,5265,5648],0); -ELEMENTS[20969] = Fluid3D([5285,5064,4755,4830],0); -ELEMENTS[20970] = Fluid3D([5265,5196,5648,5075],0); -ELEMENTS[20971] = Fluid3D([5648,5265,5075,5442],0); -ELEMENTS[20972] = Fluid3D([5648,5265,5442,6200],0); -ELEMENTS[20973] = Fluid3D([5196,4755,4772,5075],0); -ELEMENTS[20974] = Fluid3D([4772,5196,5075,5511],0); -ELEMENTS[20975] = Fluid3D([4755,5196,5265,5075],0); -ELEMENTS[20976] = Fluid3D([5196,5687,5285,5648],0); -ELEMENTS[20977] = Fluid3D([4755,5064,4772,4436],0); -ELEMENTS[20978] = Fluid3D([5285,4755,5265,4997],0); -ELEMENTS[20979] = Fluid3D([5265,5075,5442,4817],0); -ELEMENTS[20980] = Fluid3D([5265,5075,4817,4755],0); -ELEMENTS[20981] = Fluid3D([5285,4755,4997,4830],0); -ELEMENTS[20982] = Fluid3D([5442,5265,4817,5315],0); -ELEMENTS[20983] = Fluid3D([5442,5265,5315,6200],0); -ELEMENTS[20984] = Fluid3D([5075,5648,5442,5679],0); -ELEMENTS[20985] = Fluid3D([4755,5064,4436,4830],0); -ELEMENTS[20986] = Fluid3D([5265,4817,5315,4997],0); -ELEMENTS[20987] = Fluid3D([5196,5648,5075,5511],0); -ELEMENTS[20988] = Fluid3D([4817,5442,5315,5095],0); -ELEMENTS[20989] = Fluid3D([5075,5442,4817,5054],0); -ELEMENTS[20990] = Fluid3D([4817,5442,5095,5054],0); -ELEMENTS[20991] = Fluid3D([5315,4817,5095,4724],0); -ELEMENTS[20992] = Fluid3D([5095,5315,4724,5237],0); -ELEMENTS[20993] = Fluid3D([5095,5315,5237,5703],0); -ELEMENTS[20994] = Fluid3D([5095,5315,5703,5442],0); -ELEMENTS[20995] = Fluid3D([4817,5075,5054,4502],0); -ELEMENTS[20996] = Fluid3D([4817,5075,4502,4755],0); -ELEMENTS[20997] = Fluid3D([5075,5054,4502,4853],0); -ELEMENTS[20998] = Fluid3D([4502,5075,4853,4772],0); -ELEMENTS[20999] = Fluid3D([4502,5075,4772,4755],0); -ELEMENTS[21000] = Fluid3D([5054,4817,4502,4569],0); -ELEMENTS[21001] = Fluid3D([5054,4817,4569,5095],0); -ELEMENTS[21002] = Fluid3D([4817,4502,4569,4231],0); -ELEMENTS[21003] = Fluid3D([4817,4502,4231,4755],0); -ELEMENTS[21004] = Fluid3D([5075,5442,5054,5679],0); -ELEMENTS[21005] = Fluid3D([4724,5095,5237,4767],0); -ELEMENTS[21006] = Fluid3D([4724,5095,4767,4569],0); -ELEMENTS[21007] = Fluid3D([5054,4502,4853,4482],0); -ELEMENTS[21008] = Fluid3D([4502,4853,4482,4301],0); -ELEMENTS[21009] = Fluid3D([4502,4853,4301,4772],0); -ELEMENTS[21010] = Fluid3D([4482,4502,4301,4062],0); -ELEMENTS[21011] = Fluid3D([4502,4301,4062,4069],0); -ELEMENTS[21012] = Fluid3D([4502,4301,4069,4772],0); -ELEMENTS[21013] = Fluid3D([4482,4502,4062,4569],0); -ELEMENTS[21014] = Fluid3D([5054,4502,4482,4569],0); -ELEMENTS[21015] = Fluid3D([5237,5095,5703,5399],0); -ELEMENTS[21016] = Fluid3D([5095,5703,5399,5567],0); -ELEMENTS[21017] = Fluid3D([5237,5095,5399,4767],0); -ELEMENTS[21018] = Fluid3D([5703,5399,5567,6043],0); -ELEMENTS[21019] = Fluid3D([5567,5703,6043,6204],0); -ELEMENTS[21020] = Fluid3D([5703,5237,5399,5936],0); -ELEMENTS[21021] = Fluid3D([5703,5399,6043,5936],0); -ELEMENTS[21022] = Fluid3D([5237,5399,5936,5276],0); -ELEMENTS[21023] = Fluid3D([5237,5399,5276,4767],0); -ELEMENTS[21024] = Fluid3D([5399,5936,5276,5770],0); -ELEMENTS[21025] = Fluid3D([5399,5936,5770,6043],0); -ELEMENTS[21026] = Fluid3D([5703,5237,5936,5764],0); -ELEMENTS[21027] = Fluid3D([5237,5936,5764,5513],0); -ELEMENTS[21028] = Fluid3D([5936,5276,5770,5942],0); -ELEMENTS[21029] = Fluid3D([5936,5276,5942,5513],0); -ELEMENTS[21030] = Fluid3D([5764,5237,5513,5195],0); -ELEMENTS[21031] = Fluid3D([5237,5513,5195,4832],0); -ELEMENTS[21032] = Fluid3D([5764,5237,5195,5315],0); -ELEMENTS[21033] = Fluid3D([5237,5936,5513,5276],0); -ELEMENTS[21034] = Fluid3D([5703,5237,5764,5315],0); -ELEMENTS[21035] = Fluid3D([5095,5703,5567,5442],0); -ELEMENTS[21036] = Fluid3D([4817,5095,4724,4569],0); -ELEMENTS[21037] = Fluid3D([5399,5567,6043,5700],0); -ELEMENTS[21038] = Fluid3D([5567,6043,5700,6103],0); -ELEMENTS[21039] = Fluid3D([5399,5567,5700,5052],0); -ELEMENTS[21040] = Fluid3D([5399,5567,5052,5095],0); -ELEMENTS[21041] = Fluid3D([6043,5700,6103,6348],0); -ELEMENTS[21042] = Fluid3D([5567,5700,5052,5420],0); -ELEMENTS[21043] = Fluid3D([5567,5700,5420,6103],0); -ELEMENTS[21044] = Fluid3D([5052,5567,5420,5129],0); -ELEMENTS[21045] = Fluid3D([5052,5567,5129,5095],0); -ELEMENTS[21046] = Fluid3D([5567,5420,5129,5627],0); -ELEMENTS[21047] = Fluid3D([5567,5420,5627,6103],0); -ELEMENTS[21048] = Fluid3D([5700,5052,5420,5183],0); -ELEMENTS[21049] = Fluid3D([5129,5567,5627,5442],0); -ELEMENTS[21050] = Fluid3D([5052,5420,5183,4821],0); -ELEMENTS[21051] = Fluid3D([5420,5183,4821,5242],0); -ELEMENTS[21052] = Fluid3D([5420,5183,5242,5658],0); -ELEMENTS[21053] = Fluid3D([5052,5420,4821,5129],0); -ELEMENTS[21054] = Fluid3D([5700,5052,5183,5089],0); -ELEMENTS[21055] = Fluid3D([5700,5052,5089,5399],0); -ELEMENTS[21056] = Fluid3D([5183,5700,5089,5658],0); -ELEMENTS[21057] = Fluid3D([5052,5183,5089,4649],0); -ELEMENTS[21058] = Fluid3D([5052,5183,4649,4821],0); -ELEMENTS[21059] = Fluid3D([5420,5129,5627,5208],0); -ELEMENTS[21060] = Fluid3D([5627,5420,5208,5819],0); -ELEMENTS[21061] = Fluid3D([5420,5129,5208,4821],0); -ELEMENTS[21062] = Fluid3D([5129,5627,5208,5194],0); -ELEMENTS[21063] = Fluid3D([5627,5208,5194,5670],0); -ELEMENTS[21064] = Fluid3D([5627,5208,5670,5819],0); -ELEMENTS[21065] = Fluid3D([5129,5627,5194,5054],0); -ELEMENTS[21066] = Fluid3D([5194,5129,5054,4482],0); -ELEMENTS[21067] = Fluid3D([5129,5054,4482,4569],0); -ELEMENTS[21068] = Fluid3D([5129,5054,4569,5095],0); -ELEMENTS[21069] = Fluid3D([5129,5054,5095,5442],0); -ELEMENTS[21070] = Fluid3D([5129,5054,5442,5627],0); -ELEMENTS[21071] = Fluid3D([5627,5420,5819,6103],0); -ELEMENTS[21072] = Fluid3D([5194,5627,5670,5679],0); -ELEMENTS[21073] = Fluid3D([5183,5089,4649,4951],0); -ELEMENTS[21074] = Fluid3D([5183,5089,4951,5381],0); -ELEMENTS[21075] = Fluid3D([5089,4951,5381,4996],0); -ELEMENTS[21076] = Fluid3D([4951,5381,4996,5292],0); -ELEMENTS[21077] = Fluid3D([5089,4951,4996,4649],0); -ELEMENTS[21078] = Fluid3D([4649,5183,4951,4711],0); -ELEMENTS[21079] = Fluid3D([5183,4951,4711,5186],0); -ELEMENTS[21080] = Fluid3D([4951,4711,5186,4623],0); -ELEMENTS[21081] = Fluid3D([5186,4951,4623,5292],0); -ELEMENTS[21082] = Fluid3D([4951,4711,4623,4387],0); -ELEMENTS[21083] = Fluid3D([4623,4951,4387,4602],0); -ELEMENTS[21084] = Fluid3D([4623,4951,4602,5292],0); -ELEMENTS[21085] = Fluid3D([4951,4387,4602,4996],0); -ELEMENTS[21086] = Fluid3D([4602,4951,4996,5292],0); -ELEMENTS[21087] = Fluid3D([4387,4623,4602,4127],0); -ELEMENTS[21088] = Fluid3D([4623,4602,4127,4514],0); -ELEMENTS[21089] = Fluid3D([4623,4602,4514,5292],0); -ELEMENTS[21090] = Fluid3D([4127,4623,4514,4262],0); -ELEMENTS[21091] = Fluid3D([4623,4514,4262,4805],0); -ELEMENTS[21092] = Fluid3D([4127,4623,4262,4164],0); -ELEMENTS[21093] = Fluid3D([4623,4514,4805,5292],0); -ELEMENTS[21094] = Fluid3D([4127,4623,4164,4387],0); -ELEMENTS[21095] = Fluid3D([4602,4127,4514,4218],0); -ELEMENTS[21096] = Fluid3D([4514,4602,4218,4757],0); -ELEMENTS[21097] = Fluid3D([4514,4602,4757,5292],0); -ELEMENTS[21098] = Fluid3D([4602,4127,4218,4109],0); -ELEMENTS[21099] = Fluid3D([4951,4711,4387,4649],0); -ELEMENTS[21100] = Fluid3D([4387,4951,4649,4996],0); -ELEMENTS[21101] = Fluid3D([4711,4387,4649,4243],0); -ELEMENTS[21102] = Fluid3D([4387,4649,4243,4072],0); -ELEMENTS[21103] = Fluid3D([4387,4649,4072,4568],0); -ELEMENTS[21104] = Fluid3D([4387,4649,4568,4996],0); -ELEMENTS[21105] = Fluid3D([4649,4072,4568,4511],0); -ELEMENTS[21106] = Fluid3D([4072,4387,4568,4109],0); -ELEMENTS[21107] = Fluid3D([4649,4243,4072,4392],0); -ELEMENTS[21108] = Fluid3D([4243,4387,4072,3851],0); -ELEMENTS[21109] = Fluid3D([4568,4649,4511,5089],0); -ELEMENTS[21110] = Fluid3D([4072,4649,4392,4511],0); -ELEMENTS[21111] = Fluid3D([4387,4072,3851,4109],0); -ELEMENTS[21112] = Fluid3D([4649,4243,4392,4821],0); -ELEMENTS[21113] = Fluid3D([4243,4387,3851,4164],0); -ELEMENTS[21114] = Fluid3D([4649,4711,4243,4821],0); -ELEMENTS[21115] = Fluid3D([4649,4392,4511,5052],0); -ELEMENTS[21116] = Fluid3D([4243,4072,4392,3907],0); -ELEMENTS[21117] = Fluid3D([4072,4392,3907,4116],0); -ELEMENTS[21118] = Fluid3D([4072,4392,4116,4511],0); -ELEMENTS[21119] = Fluid3D([4392,4243,3907,4103],0); -ELEMENTS[21120] = Fluid3D([4392,4243,4103,4821],0); -ELEMENTS[21121] = Fluid3D([3907,4392,4103,3989],0); -ELEMENTS[21122] = Fluid3D([3907,4392,3989,4116],0); -ELEMENTS[21123] = Fluid3D([4072,4568,4511,4296],0); -ELEMENTS[21124] = Fluid3D([4568,4511,4296,4753],0); -ELEMENTS[21125] = Fluid3D([4511,4072,4296,4116],0); -ELEMENTS[21126] = Fluid3D([4511,4296,4753,4767],0); -ELEMENTS[21127] = Fluid3D([4753,4511,4767,5089],0); -ELEMENTS[21128] = Fluid3D([4511,4296,4767,4116],0); -ELEMENTS[21129] = Fluid3D([4568,4511,4753,5089],0); -ELEMENTS[21130] = Fluid3D([4072,4243,3851,3907],0); -ELEMENTS[21131] = Fluid3D([4649,5183,4711,4821],0); -ELEMENTS[21132] = Fluid3D([4711,4387,4243,4164],0); -ELEMENTS[21133] = Fluid3D([4602,4387,4127,4109],0); -ELEMENTS[21134] = Fluid3D([4514,4262,4805,4439],0); -ELEMENTS[21135] = Fluid3D([4805,4514,4439,4940],0); -ELEMENTS[21136] = Fluid3D([4514,4262,4439,4029],0); -ELEMENTS[21137] = Fluid3D([4514,4262,4029,4127],0); -ELEMENTS[21138] = Fluid3D([4262,4805,4439,4098],0); -ELEMENTS[21139] = Fluid3D([4805,4514,4940,5292],0); -ELEMENTS[21140] = Fluid3D([4514,4439,4940,4445],0); -ELEMENTS[21141] = Fluid3D([4514,4439,4445,4029],0); -ELEMENTS[21142] = Fluid3D([4940,4514,4445,4757],0); -ELEMENTS[21143] = Fluid3D([4439,4940,4445,4604],0); -ELEMENTS[21144] = Fluid3D([4127,4514,4218,4029],0); -ELEMENTS[21145] = Fluid3D([6043,5399,5700,5770],0); -ELEMENTS[21146] = Fluid3D([5420,5208,5819,5242],0); -ELEMENTS[21147] = Fluid3D([5183,4821,5242,4711],0); -ELEMENTS[21148] = Fluid3D([4127,4218,4109,3767],0); -ELEMENTS[21149] = Fluid3D([4109,4127,3767,3851],0); -ELEMENTS[21150] = Fluid3D([4127,4218,3767,4029],0); -ELEMENTS[21151] = Fluid3D([4218,4109,3767,3924],0); -ELEMENTS[21152] = Fluid3D([4109,3767,3924,3667],0); -ELEMENTS[21153] = Fluid3D([4109,3767,3667,3851],0); -ELEMENTS[21154] = Fluid3D([4218,4109,3924,4525],0); -ELEMENTS[21155] = Fluid3D([4218,4109,4525,4602],0); -ELEMENTS[21156] = Fluid3D([3924,4218,4525,4266],0); -ELEMENTS[21157] = Fluid3D([4218,4525,4266,4757],0); -ELEMENTS[21158] = Fluid3D([3924,4218,4266,3848],0); -ELEMENTS[21159] = Fluid3D([4218,4266,3848,4306],0); -ELEMENTS[21160] = Fluid3D([4218,4266,4306,4757],0); -ELEMENTS[21161] = Fluid3D([3924,4218,3848,3767],0); -ELEMENTS[21162] = Fluid3D([4109,3924,4525,4097],0); -ELEMENTS[21163] = Fluid3D([4109,3924,4097,3667],0); -ELEMENTS[21164] = Fluid3D([4525,4109,4097,4568],0); -ELEMENTS[21165] = Fluid3D([3924,4525,4097,4196],0); -ELEMENTS[21166] = Fluid3D([3924,4525,4196,4266],0); -ELEMENTS[21167] = Fluid3D([4525,4097,4196,4583],0); -ELEMENTS[21168] = Fluid3D([4097,4196,4583,4037],0); -ELEMENTS[21169] = Fluid3D([4525,4097,4583,4568],0); -ELEMENTS[21170] = Fluid3D([3767,3924,3667,3471],0); -ELEMENTS[21171] = Fluid3D([3667,3767,3471,3361],0); -ELEMENTS[21172] = Fluid3D([3767,3924,3471,3848],0); -ELEMENTS[21173] = Fluid3D([3924,3667,3471,3619],0); -ELEMENTS[21174] = Fluid3D([3667,3471,3619,3263],0); -ELEMENTS[21175] = Fluid3D([3667,3471,3263,3361],0); -ELEMENTS[21176] = Fluid3D([3924,3667,3619,4097],0); -ELEMENTS[21177] = Fluid3D([3667,3767,3361,3851],0); -ELEMENTS[21178] = Fluid3D([3767,3471,3361,3397],0); -ELEMENTS[21179] = Fluid3D([3767,3471,3397,3848],0); -ELEMENTS[21180] = Fluid3D([3361,3767,3397,3611],0); -ELEMENTS[21181] = Fluid3D([3767,3397,3611,4029],0); -ELEMENTS[21182] = Fluid3D([3471,3361,3397,3120],0); -ELEMENTS[21183] = Fluid3D([3361,3397,3120,3078],0); -ELEMENTS[21184] = Fluid3D([3397,3120,3078,3257],0); -ELEMENTS[21185] = Fluid3D([3078,3397,3257,3453],0); -ELEMENTS[21186] = Fluid3D([3397,3257,3453,3656],0); -ELEMENTS[21187] = Fluid3D([3078,3397,3453,3611],0); -ELEMENTS[21188] = Fluid3D([3397,3453,3611,4029],0); -ELEMENTS[21189] = Fluid3D([3397,3120,3257,3471],0); -ELEMENTS[21190] = Fluid3D([3361,3397,3078,3611],0); -ELEMENTS[21191] = Fluid3D([3120,3361,3078,2756],0); -ELEMENTS[21192] = Fluid3D([3471,3361,3120,3263],0); -ELEMENTS[21193] = Fluid3D([3397,3257,3656,3848],0); -ELEMENTS[21194] = Fluid3D([3257,3397,3471,3848],0); -ELEMENTS[21195] = Fluid3D([3361,3767,3611,3851],0); -ELEMENTS[21196] = Fluid3D([4266,3924,3848,3817],0); -ELEMENTS[21197] = Fluid3D([3848,4266,3817,3965],0); -ELEMENTS[21198] = Fluid3D([3924,3848,3817,3471],0); -ELEMENTS[21199] = Fluid3D([4266,3924,3817,4196],0); -ELEMENTS[21200] = Fluid3D([3848,4266,3965,4306],0); -ELEMENTS[21201] = Fluid3D([4266,3817,3965,4228],0); -ELEMENTS[21202] = Fluid3D([3965,4266,4228,4734],0); -ELEMENTS[21203] = Fluid3D([3817,3965,4228,3682],0); -ELEMENTS[21204] = Fluid3D([3817,3965,3682,3549],0); -ELEMENTS[21205] = Fluid3D([3817,3965,3549,3848],0); -ELEMENTS[21206] = Fluid3D([4266,3817,4228,4196],0); -ELEMENTS[21207] = Fluid3D([3965,4228,3682,4281],0); -ELEMENTS[21208] = Fluid3D([4266,4228,4734,4500],0); -ELEMENTS[21209] = Fluid3D([4228,4734,4500,4337],0); -ELEMENTS[21210] = Fluid3D([4228,4734,4337,4281],0); -ELEMENTS[21211] = Fluid3D([4500,4228,4337,4028],0); -ELEMENTS[21212] = Fluid3D([4228,4337,4028,3682],0); -ELEMENTS[21213] = Fluid3D([4337,4228,4281,3682],0); -ELEMENTS[21214] = Fluid3D([4500,4228,4028,4196],0); -ELEMENTS[21215] = Fluid3D([4228,4734,4281,3965],0); -ELEMENTS[21216] = Fluid3D([4337,4500,4028,4180],0); -ELEMENTS[21217] = Fluid3D([4028,4500,4196,4241],0); -ELEMENTS[21218] = Fluid3D([4266,4228,4500,4196],0); -ELEMENTS[21219] = Fluid3D([4028,4337,4180,3768],0); -ELEMENTS[21220] = Fluid3D([3078,3120,2756,2902],0); -ELEMENTS[21221] = Fluid3D([3078,3120,2902,3257],0); -ELEMENTS[21222] = Fluid3D([3120,2756,2902,2607],0); -ELEMENTS[21223] = Fluid3D([3120,2902,3257,3092],0); -ELEMENTS[21224] = Fluid3D([4097,3924,4196,3619],0); -ELEMENTS[21225] = Fluid3D([4196,4525,4583,4500],0); -ELEMENTS[21226] = Fluid3D([5567,6043,6103,6204],0); -ELEMENTS[21227] = Fluid3D([5089,5052,4649,4511],0); -ELEMENTS[21228] = Fluid3D([4228,3817,3682,4028],0); -ELEMENTS[21229] = Fluid3D([4228,3817,4028,4196],0); -ELEMENTS[21230] = Fluid3D([5315,4817,4724,4778],0); -ELEMENTS[21231] = Fluid3D([5315,4817,4778,4997],0); -ELEMENTS[21232] = Fluid3D([4724,5315,4778,5195],0); -ELEMENTS[21233] = Fluid3D([4817,4724,4778,4231],0); -ELEMENTS[21234] = Fluid3D([4502,4569,4231,4062],0); -ELEMENTS[21235] = Fluid3D([5770,5936,5942,6715],0); -ELEMENTS[21236] = Fluid3D([4262,4127,4164,3843],0); -ELEMENTS[21237] = Fluid3D([4127,4164,3843,3851],0); -ELEMENTS[21238] = Fluid3D([4262,4127,3843,4029],0); -ELEMENTS[21239] = Fluid3D([4164,4262,3843,3900],0); -ELEMENTS[21240] = Fluid3D([4301,4062,4069,3793],0); -ELEMENTS[21241] = Fluid3D([4069,4301,3793,4064],0); -ELEMENTS[21242] = Fluid3D([4301,4062,3793,4000],0); -ELEMENTS[21243] = Fluid3D([4301,4062,4000,4482],0); -ELEMENTS[21244] = Fluid3D([4301,3793,4064,4026],0); -ELEMENTS[21245] = Fluid3D([4301,3793,4026,4000],0); -ELEMENTS[21246] = Fluid3D([4062,3793,4000,3616],0); -ELEMENTS[21247] = Fluid3D([4000,4062,3616,3989],0); -ELEMENTS[21248] = Fluid3D([4062,3616,3989,3802],0); -ELEMENTS[21249] = Fluid3D([3989,4062,3802,4231],0); -ELEMENTS[21250] = Fluid3D([4062,3616,3802,3793],0); -ELEMENTS[21251] = Fluid3D([4000,4062,3989,4482],0); -ELEMENTS[21252] = Fluid3D([4062,3989,4482,4569],0); -ELEMENTS[21253] = Fluid3D([4062,3989,4569,4231],0); -ELEMENTS[21254] = Fluid3D([3793,4064,4026,3649],0); -ELEMENTS[21255] = Fluid3D([4026,3793,3649,3582],0); -ELEMENTS[21256] = Fluid3D([3649,4026,3582,3708],0); -ELEMENTS[21257] = Fluid3D([3649,4026,3708,4015],0); -ELEMENTS[21258] = Fluid3D([3649,4026,4015,4064],0); -ELEMENTS[21259] = Fluid3D([3793,4064,3649,3658],0); -ELEMENTS[21260] = Fluid3D([3793,4064,3658,4069],0); -ELEMENTS[21261] = Fluid3D([4064,3649,3658,3795],0); -ELEMENTS[21262] = Fluid3D([4064,3649,3795,4015],0); -ELEMENTS[21263] = Fluid3D([3658,4064,3795,3970],0); -ELEMENTS[21264] = Fluid3D([3658,4064,3970,4069],0); -ELEMENTS[21265] = Fluid3D([4064,3795,3970,4305],0); -ELEMENTS[21266] = Fluid3D([3795,3970,4305,3877],0); -ELEMENTS[21267] = Fluid3D([4064,3795,4305,4015],0); -ELEMENTS[21268] = Fluid3D([4026,3793,3582,4000],0); -ELEMENTS[21269] = Fluid3D([3649,3793,3658,3360],0); -ELEMENTS[21270] = Fluid3D([3649,3793,3360,3582],0); -ELEMENTS[21271] = Fluid3D([3793,3658,3360,3551],0); -ELEMENTS[21272] = Fluid3D([3658,3649,3360,3090],0); -ELEMENTS[21273] = Fluid3D([3658,3360,3551,3259],0); -ELEMENTS[21274] = Fluid3D([3360,3551,3259,3128],0); -ELEMENTS[21275] = Fluid3D([3360,3551,3128,3616],0); -ELEMENTS[21276] = Fluid3D([3658,3360,3259,3090],0); -ELEMENTS[21277] = Fluid3D([3708,3649,4015,3306],0); -ELEMENTS[21278] = Fluid3D([3793,3658,3551,4069],0); -ELEMENTS[21279] = Fluid3D([3551,3658,3259,3635],0); -ELEMENTS[21280] = Fluid3D([3551,3658,3635,4069],0); -ELEMENTS[21281] = Fluid3D([3658,3259,3635,3235],0); -ELEMENTS[21282] = Fluid3D([3259,3551,3635,3347],0); -ELEMENTS[21283] = Fluid3D([3259,3551,3347,3128],0); -ELEMENTS[21284] = Fluid3D([3551,3635,3347,3740],0); -ELEMENTS[21285] = Fluid3D([3551,3635,3740,4069],0); -ELEMENTS[21286] = Fluid3D([3347,3551,3740,3802],0); -ELEMENTS[21287] = Fluid3D([3551,3740,3802,4069],0); -ELEMENTS[21288] = Fluid3D([3635,3347,3740,3568],0); -ELEMENTS[21289] = Fluid3D([3740,3635,3568,4010],0); -ELEMENTS[21290] = Fluid3D([3635,3347,3568,3274],0); -ELEMENTS[21291] = Fluid3D([3635,3347,3274,3259],0); -ELEMENTS[21292] = Fluid3D([3347,3740,3568,3447],0); -ELEMENTS[21293] = Fluid3D([3740,3568,3447,3880],0); -ELEMENTS[21294] = Fluid3D([3740,3568,3880,4010],0); -ELEMENTS[21295] = Fluid3D([3347,3740,3447,3387],0); -ELEMENTS[21296] = Fluid3D([3347,3740,3387,3802],0); -ELEMENTS[21297] = Fluid3D([3740,3387,3802,3712],0); -ELEMENTS[21298] = Fluid3D([3387,3802,3712,3586],0); -ELEMENTS[21299] = Fluid3D([3387,3802,3586,3403],0); -ELEMENTS[21300] = Fluid3D([3387,3802,3403,3128],0); -ELEMENTS[21301] = Fluid3D([3802,3586,3403,3989],0); -ELEMENTS[21302] = Fluid3D([3802,3712,3586,4116],0); -ELEMENTS[21303] = Fluid3D([3586,3387,3403,3143],0); -ELEMENTS[21304] = Fluid3D([3712,3387,3586,3373],0); -ELEMENTS[21305] = Fluid3D([3387,3403,3143,3128],0); -ELEMENTS[21306] = Fluid3D([3586,3387,3143,3373],0); -ELEMENTS[21307] = Fluid3D([3712,3387,3373,3447],0); -ELEMENTS[21308] = Fluid3D([3802,3740,3712,4231],0); -ELEMENTS[21309] = Fluid3D([3387,3143,3373,3069],0); -ELEMENTS[21310] = Fluid3D([3387,3143,3069,3128],0); -ELEMENTS[21311] = Fluid3D([3373,3387,3069,3447],0); -ELEMENTS[21312] = Fluid3D([3740,3387,3712,3447],0); -ELEMENTS[21313] = Fluid3D([3143,3586,3373,3290],0); -ELEMENTS[21314] = Fluid3D([3403,3586,3143,3307],0); -ELEMENTS[21315] = Fluid3D([3143,3373,3069,2978],0); -ELEMENTS[21316] = Fluid3D([3586,3143,3307,3290],0); -ELEMENTS[21317] = Fluid3D([3373,3069,2978,3138],0); -ELEMENTS[21318] = Fluid3D([3373,3069,3138,3447],0); -ELEMENTS[21319] = Fluid3D([3373,3143,3290,2978],0); -ELEMENTS[21320] = Fluid3D([3586,3373,3290,3700],0); -ELEMENTS[21321] = Fluid3D([3586,3373,3700,3712],0); -ELEMENTS[21322] = Fluid3D([3290,3586,3700,3681],0); -ELEMENTS[21323] = Fluid3D([3290,3586,3681,3307],0); -ELEMENTS[21324] = Fluid3D([3373,3290,3700,3320],0); -ELEMENTS[21325] = Fluid3D([3700,3373,3320,3868],0); -ELEMENTS[21326] = Fluid3D([3373,3290,3320,2978],0); -ELEMENTS[21327] = Fluid3D([3069,3143,2978,2803],0); -ELEMENTS[21328] = Fluid3D([3069,3143,2803,3128],0); -ELEMENTS[21329] = Fluid3D([2978,3069,2803,2760],0); -ELEMENTS[21330] = Fluid3D([3586,3700,3681,4116],0); -ELEMENTS[21331] = Fluid3D([3143,3403,3307,3023],0); -ELEMENTS[21332] = Fluid3D([3143,3403,3023,3128],0); -ELEMENTS[21333] = Fluid3D([3307,3143,3023,2948],0); -ELEMENTS[21334] = Fluid3D([3143,3023,2948,2803],0); -ELEMENTS[21335] = Fluid3D([3307,3143,2948,3290],0); -ELEMENTS[21336] = Fluid3D([2978,3373,3138,3320],0); -ELEMENTS[21337] = Fluid3D([3403,3586,3307,3907],0); -ELEMENTS[21338] = Fluid3D([3447,3347,3387,3069],0); -ELEMENTS[21339] = Fluid3D([3740,3635,4010,4069],0); -ELEMENTS[21340] = Fluid3D([3635,3568,4010,3723],0); -ELEMENTS[21341] = Fluid3D([3635,3568,3723,3274],0); -ELEMENTS[21342] = Fluid3D([4010,3635,3723,4019],0); -ELEMENTS[21343] = Fluid3D([3635,3723,4019,3584],0); -ELEMENTS[21344] = Fluid3D([3635,3723,3584,3274],0); -ELEMENTS[21345] = Fluid3D([3568,4010,3723,3902],0); -ELEMENTS[21346] = Fluid3D([4010,3723,3902,4352],0); -ELEMENTS[21347] = Fluid3D([3568,4010,3902,3880],0); -ELEMENTS[21348] = Fluid3D([4010,3635,4019,4069],0); -ELEMENTS[21349] = Fluid3D([3723,4010,4019,4436],0); -ELEMENTS[21350] = Fluid3D([4010,4019,4436,4069],0); -ELEMENTS[21351] = Fluid3D([3568,3347,3447,3155],0); -ELEMENTS[21352] = Fluid3D([3568,3347,3155,3274],0); -ELEMENTS[21353] = Fluid3D([3347,3447,3155,3069],0); -ELEMENTS[21354] = Fluid3D([3447,3568,3155,3478],0); -ELEMENTS[21355] = Fluid3D([3447,3568,3478,3880],0); -ELEMENTS[21356] = Fluid3D([3568,3155,3478,3356],0); -ELEMENTS[21357] = Fluid3D([3568,3155,3356,3274],0); -ELEMENTS[21358] = Fluid3D([3478,3568,3356,3902],0); -ELEMENTS[21359] = Fluid3D([3155,3447,3478,3138],0); -ELEMENTS[21360] = Fluid3D([3155,3478,3356,3103],0); -ELEMENTS[21361] = Fluid3D([3478,3356,3103,3460],0); -ELEMENTS[21362] = Fluid3D([3356,3103,3460,3012],0); -ELEMENTS[21363] = Fluid3D([3155,3478,3103,3138],0); -ELEMENTS[21364] = Fluid3D([3356,3155,3103,2853],0); -ELEMENTS[21365] = Fluid3D([3478,3356,3460,3902],0); -ELEMENTS[21366] = Fluid3D([3103,3478,3460,3342],0); -ELEMENTS[21367] = Fluid3D([3478,3460,3342,3777],0); -ELEMENTS[21368] = Fluid3D([3103,3478,3342,3138],0); -ELEMENTS[21369] = Fluid3D([3460,3342,3777,3569],0); -ELEMENTS[21370] = Fluid3D([3460,3342,3569,3154],0); -ELEMENTS[21371] = Fluid3D([3460,3342,3154,3103],0); -ELEMENTS[21372] = Fluid3D([3342,3777,3569,3418],0); -ELEMENTS[21373] = Fluid3D([3478,3460,3777,3902],0); -ELEMENTS[21374] = Fluid3D([3342,3478,3777,3598],0); -ELEMENTS[21375] = Fluid3D([3478,3777,3598,3880],0); -ELEMENTS[21376] = Fluid3D([3342,3478,3598,3138],0); -ELEMENTS[21377] = Fluid3D([3777,3342,3598,3418],0); -ELEMENTS[21378] = Fluid3D([3342,3598,3418,3138],0); -ELEMENTS[21379] = Fluid3D([4062,4069,3793,3802],0); -ELEMENTS[21380] = Fluid3D([3582,3649,3708,3292],0); -ELEMENTS[21381] = Fluid3D([3649,3708,3292,3306],0); -ELEMENTS[21382] = Fluid3D([3708,3582,3292,3413],0); -ELEMENTS[21383] = Fluid3D([3708,3582,3413,3846],0); -ELEMENTS[21384] = Fluid3D([3292,3708,3413,3370],0); -ELEMENTS[21385] = Fluid3D([3292,3708,3370,3306],0); -ELEMENTS[21386] = Fluid3D([3582,3649,3292,3360],0); -ELEMENTS[21387] = Fluid3D([3708,3582,3846,4026],0); -ELEMENTS[21388] = Fluid3D([3413,3708,3846,3725],0); -ELEMENTS[21389] = Fluid3D([3413,3708,3725,3370],0); -ELEMENTS[21390] = Fluid3D([3708,3846,3725,4131],0); -ELEMENTS[21391] = Fluid3D([3846,3725,4131,4100],0); -ELEMENTS[21392] = Fluid3D([3846,3413,3725,3591],0); -ELEMENTS[21393] = Fluid3D([3846,3725,4100,3591],0); -ELEMENTS[21394] = Fluid3D([3846,3413,3591,3503],0); -ELEMENTS[21395] = Fluid3D([3413,3591,3503,3210],0); -ELEMENTS[21396] = Fluid3D([3413,3591,3210,3314],0); -ELEMENTS[21397] = Fluid3D([3413,3591,3314,3725],0); -ELEMENTS[21398] = Fluid3D([3846,3413,3503,3582],0); -ELEMENTS[21399] = Fluid3D([3708,3846,4131,4026],0); -ELEMENTS[21400] = Fluid3D([3582,3292,3413,3159],0); -ELEMENTS[21401] = Fluid3D([3413,3582,3159,3503],0); -ELEMENTS[21402] = Fluid3D([3582,3292,3159,3360],0); -ELEMENTS[21403] = Fluid3D([3292,3413,3159,3015],0); -ELEMENTS[21404] = Fluid3D([3292,3413,3015,3370],0); -ELEMENTS[21405] = Fluid3D([3159,3292,3015,2962],0); -ELEMENTS[21406] = Fluid3D([3292,3015,2962,3207],0); -ELEMENTS[21407] = Fluid3D([3725,3708,4131,3867],0); -ELEMENTS[21408] = Fluid3D([3725,3708,3867,3370],0); -ELEMENTS[21409] = Fluid3D([3708,4131,3867,4015],0); -ELEMENTS[21410] = Fluid3D([4131,3725,3867,4138],0); -ELEMENTS[21411] = Fluid3D([3413,3159,3015,3210],0); -ELEMENTS[21412] = Fluid3D([3649,3658,3795,3459],0); -ELEMENTS[21413] = Fluid3D([3725,4131,4100,4138],0); -ELEMENTS[21414] = Fluid3D([4069,4301,4064,4772],0); -ELEMENTS[21415] = Fluid3D([4064,4301,4026,4489],0); -ELEMENTS[21416] = Fluid3D([4064,4301,4489,4772],0); -ELEMENTS[21417] = Fluid3D([4301,4026,4489,4471],0); -ELEMENTS[21418] = Fluid3D([4026,4064,4489,4015],0); -ELEMENTS[21419] = Fluid3D([4026,4489,4471,4131],0); -ELEMENTS[21420] = Fluid3D([4301,4026,4471,4000],0); -ELEMENTS[21421] = Fluid3D([4489,4301,4471,4853],0); -ELEMENTS[21422] = Fluid3D([3970,4064,4305,4802],0); -ELEMENTS[21423] = Fluid3D([3793,4000,3616,3582],0); -ELEMENTS[21424] = Fluid3D([4026,3708,4015,4131],0); -ELEMENTS[21425] = Fluid3D([3360,3793,3551,3616],0); -ELEMENTS[21426] = Fluid3D([5420,5700,5183,5658],0); -ELEMENTS[21427] = Fluid3D([3795,3658,3970,3584],0); -ELEMENTS[21428] = Fluid3D([4131,3846,4100,4367],0); -ELEMENTS[21429] = Fluid3D([4131,3846,4367,4026],0); -ELEMENTS[21430] = Fluid3D([3846,4100,4367,4067],0); -ELEMENTS[21431] = Fluid3D([3846,4100,4067,3591],0); -ELEMENTS[21432] = Fluid3D([4367,3846,4067,4000],0); -ELEMENTS[21433] = Fluid3D([4100,4131,4367,4632],0); -ELEMENTS[21434] = Fluid3D([4100,4367,4067,4626],0); -ELEMENTS[21435] = Fluid3D([4367,4067,4626,4533],0); -ELEMENTS[21436] = Fluid3D([4067,4626,4533,4393],0); -ELEMENTS[21437] = Fluid3D([4067,4626,4393,4225],0); -ELEMENTS[21438] = Fluid3D([4067,4626,4225,4100],0); -ELEMENTS[21439] = Fluid3D([4100,4367,4626,4632],0); -ELEMENTS[21440] = Fluid3D([4626,4533,4393,4888],0); -ELEMENTS[21441] = Fluid3D([4393,4626,4888,4773],0); -ELEMENTS[21442] = Fluid3D([4626,4888,4773,5163],0); -ELEMENTS[21443] = Fluid3D([4773,4626,5163,4632],0); -ELEMENTS[21444] = Fluid3D([4773,4626,4632,4172],0); -ELEMENTS[21445] = Fluid3D([4626,4533,4888,4928],0); -ELEMENTS[21446] = Fluid3D([4626,4533,4928,4367],0); -ELEMENTS[21447] = Fluid3D([4533,4393,4888,4713],0); -ELEMENTS[21448] = Fluid3D([4393,4888,4713,4825],0); -ELEMENTS[21449] = Fluid3D([4888,4713,4825,5286],0); -ELEMENTS[21450] = Fluid3D([4533,4888,4928,5320],0); -ELEMENTS[21451] = Fluid3D([4888,4713,5286,5320],0); -ELEMENTS[21452] = Fluid3D([4533,4888,5320,4713],0); -ELEMENTS[21453] = Fluid3D([4393,4888,4825,4886],0); -ELEMENTS[21454] = Fluid3D([4533,4393,4713,4176],0); -ELEMENTS[21455] = Fluid3D([4533,4393,4176,4067],0); -ELEMENTS[21456] = Fluid3D([4393,4713,4176,4325],0); -ELEMENTS[21457] = Fluid3D([4713,4533,4176,4556],0); -ELEMENTS[21458] = Fluid3D([4713,4533,4556,5320],0); -ELEMENTS[21459] = Fluid3D([4713,4176,4325,4407],0); -ELEMENTS[21460] = Fluid3D([4713,4176,4407,4556],0); -ELEMENTS[21461] = Fluid3D([4176,4325,4407,3951],0); -ELEMENTS[21462] = Fluid3D([4176,4325,3951,3881],0); -ELEMENTS[21463] = Fluid3D([4176,4325,3881,4393],0); -ELEMENTS[21464] = Fluid3D([4407,4176,3951,4103],0); -ELEMENTS[21465] = Fluid3D([4393,4713,4325,4825],0); -ELEMENTS[21466] = Fluid3D([4533,4176,4556,4139],0); -ELEMENTS[21467] = Fluid3D([4533,4176,4139,4067],0); -ELEMENTS[21468] = Fluid3D([4556,4533,4139,4646],0); -ELEMENTS[21469] = Fluid3D([4533,4139,4646,4367],0); -ELEMENTS[21470] = Fluid3D([4176,4556,4139,4103],0); -ELEMENTS[21471] = Fluid3D([4556,4139,4103,4482],0); -ELEMENTS[21472] = Fluid3D([4888,4928,5320,5760],0); -ELEMENTS[21473] = Fluid3D([4556,4533,4646,5320],0); -ELEMENTS[21474] = Fluid3D([4139,4556,4646,4482],0); -ELEMENTS[21475] = Fluid3D([4646,4139,4482,4471],0); -ELEMENTS[21476] = Fluid3D([4482,4646,4471,4853],0); -ELEMENTS[21477] = Fluid3D([4482,4646,4853,5194],0); -ELEMENTS[21478] = Fluid3D([4646,4853,5194,5084],0); -ELEMENTS[21479] = Fluid3D([4853,5194,5084,5218],0); -ELEMENTS[21480] = Fluid3D([5084,4853,5218,4489],0); -ELEMENTS[21481] = Fluid3D([4853,5194,5218,5075],0); -ELEMENTS[21482] = Fluid3D([4646,4139,4471,4367],0); -ELEMENTS[21483] = Fluid3D([4471,4646,4367,4928],0); -ELEMENTS[21484] = Fluid3D([4367,4067,4533,4139],0); -ELEMENTS[21485] = Fluid3D([4888,4626,4928,5163],0); -ELEMENTS[21486] = Fluid3D([4626,4928,5163,4632],0); -ELEMENTS[21487] = Fluid3D([4713,4825,5286,4944],0); -ELEMENTS[21488] = Fluid3D([4825,5286,4944,5569],0); -ELEMENTS[21489] = Fluid3D([5286,4944,5569,5434],0); -ELEMENTS[21490] = Fluid3D([5569,5286,5434,5911],0); -ELEMENTS[21491] = Fluid3D([5569,5286,5911,5548],0); -ELEMENTS[21492] = Fluid3D([5286,5434,5911,5495],0); -ELEMENTS[21493] = Fluid3D([5286,5434,5495,4713],0); -ELEMENTS[21494] = Fluid3D([5911,5286,5495,5946],0); -ELEMENTS[21495] = Fluid3D([5434,5569,5911,6019],0); -ELEMENTS[21496] = Fluid3D([5569,5911,6019,6145],0); -ELEMENTS[21497] = Fluid3D([5569,5911,6145,5548],0); -ELEMENTS[21498] = Fluid3D([5434,5569,6019,5437],0); -ELEMENTS[21499] = Fluid3D([5434,5569,5437,4944],0); -ELEMENTS[21500] = Fluid3D([5569,6019,5437,5913],0); -ELEMENTS[21501] = Fluid3D([5569,6019,5913,6385],0); -ELEMENTS[21502] = Fluid3D([5437,5569,5913,5288],0); -ELEMENTS[21503] = Fluid3D([5437,5569,5288,4944],0); -ELEMENTS[21504] = Fluid3D([5286,4944,5434,4713],0); -ELEMENTS[21505] = Fluid3D([5569,5913,5288,5832],0); -ELEMENTS[21506] = Fluid3D([5569,5913,5832,6385],0); -ELEMENTS[21507] = Fluid3D([5913,5832,6385,5964],0); -ELEMENTS[21508] = Fluid3D([6019,5437,5913,6023],0); -ELEMENTS[21509] = Fluid3D([4713,4825,4944,4325],0); -ELEMENTS[21510] = Fluid3D([5569,5286,5548,4825],0); -ELEMENTS[21511] = Fluid3D([6019,5437,6023,5751],0); -ELEMENTS[21512] = Fluid3D([6019,5437,5751,5434],0); -ELEMENTS[21513] = Fluid3D([6023,6019,5751,6441],0); -ELEMENTS[21514] = Fluid3D([6023,6019,6441,6613],0); -ELEMENTS[21515] = Fluid3D([6023,6019,6613,5913],0); -ELEMENTS[21516] = Fluid3D([5437,6023,5751,5460],0); -ELEMENTS[21517] = Fluid3D([6023,5751,5460,6164],0); -ELEMENTS[21518] = Fluid3D([5437,6023,5460,5546],0); -ELEMENTS[21519] = Fluid3D([6023,5460,5546,5917],0); -ELEMENTS[21520] = Fluid3D([6023,5460,5917,6164],0); -ELEMENTS[21521] = Fluid3D([5437,6023,5546,5913],0); -ELEMENTS[21522] = Fluid3D([6019,5751,6441,6334],0); -ELEMENTS[21523] = Fluid3D([5911,5434,6019,6024],0); -ELEMENTS[21524] = Fluid3D([6019,5911,6024,6574],0); -ELEMENTS[21525] = Fluid3D([6019,5911,6574,6145],0); -ELEMENTS[21526] = Fluid3D([5434,6019,6024,5751],0); -ELEMENTS[21527] = Fluid3D([5911,5434,6024,5495],0); -ELEMENTS[21528] = Fluid3D([6024,6019,6574,6334],0); -ELEMENTS[21529] = Fluid3D([6574,6024,6334,6542],0); -ELEMENTS[21530] = Fluid3D([6024,6334,6542,5999],0); -ELEMENTS[21531] = Fluid3D([6024,6334,5999,5658],0); -ELEMENTS[21532] = Fluid3D([6542,6024,5999,5819],0); -ELEMENTS[21533] = Fluid3D([6024,5999,5819,5242],0); -ELEMENTS[21534] = Fluid3D([6542,6024,5819,5911],0); -ELEMENTS[21535] = Fluid3D([6334,6542,5999,6818],0); -ELEMENTS[21536] = Fluid3D([6334,6542,6818,7191],0); -ELEMENTS[21537] = Fluid3D([6542,6818,7191,7422],0); -ELEMENTS[21538] = Fluid3D([6542,6818,7422,6729],0); -ELEMENTS[21539] = Fluid3D([6542,5999,6818,6729],0); -ELEMENTS[21540] = Fluid3D([6574,6024,6542,5911],0); -ELEMENTS[21541] = Fluid3D([5999,6542,5819,6729],0); -ELEMENTS[21542] = Fluid3D([5999,6334,6818,6348],0); -ELEMENTS[21543] = Fluid3D([5999,6334,6348,5658],0); -ELEMENTS[21544] = Fluid3D([5913,5437,5288,5546],0); -ELEMENTS[21545] = Fluid3D([5751,6023,6441,6164],0); -ELEMENTS[21546] = Fluid3D([5751,5437,5460,5113],0); -ELEMENTS[21547] = Fluid3D([5751,5437,5113,5434],0); -ELEMENTS[21548] = Fluid3D([5460,5751,5113,5186],0); -ELEMENTS[21549] = Fluid3D([5437,5460,5113,4950],0); -ELEMENTS[21550] = Fluid3D([5460,5113,4950,4915],0); -ELEMENTS[21551] = Fluid3D([5113,4950,4915,4528],0); -ELEMENTS[21552] = Fluid3D([4950,4915,4528,4495],0); -ELEMENTS[21553] = Fluid3D([4950,4915,4495,5043],0); -ELEMENTS[21554] = Fluid3D([4950,4915,5043,5460],0); -ELEMENTS[21555] = Fluid3D([5437,5460,4950,5546],0); -ELEMENTS[21556] = Fluid3D([5113,4950,4528,4944],0); -ELEMENTS[21557] = Fluid3D([4915,4528,4495,4262],0); -ELEMENTS[21558] = Fluid3D([5460,5113,4915,5186],0); -ELEMENTS[21559] = Fluid3D([5113,4915,5186,4711],0); -ELEMENTS[21560] = Fluid3D([5186,5113,4711,5183],0); -ELEMENTS[21561] = Fluid3D([5113,5437,4950,4944],0); -ELEMENTS[21562] = Fluid3D([4915,5113,4528,4711],0); -ELEMENTS[21563] = Fluid3D([4528,4950,4495,4420],0); -ELEMENTS[21564] = Fluid3D([4528,4950,4420,4944],0); -ELEMENTS[21565] = Fluid3D([4950,4495,4420,4381],0); -ELEMENTS[21566] = Fluid3D([4495,4420,4381,3900],0); -ELEMENTS[21567] = Fluid3D([4495,4528,4420,3900],0); -ELEMENTS[21568] = Fluid3D([4626,4393,4225,4773],0); -ELEMENTS[21569] = Fluid3D([4225,4626,4773,4172],0); -ELEMENTS[21570] = Fluid3D([4325,4713,4407,4944],0); -ELEMENTS[21571] = Fluid3D([6019,6441,6613,6574],0); -ELEMENTS[21572] = Fluid3D([4928,4533,5320,4646],0); -ELEMENTS[21573] = Fluid3D([4325,4407,3951,4248],0); -ELEMENTS[21574] = Fluid3D([4325,4407,4248,4944],0); -ELEMENTS[21575] = Fluid3D([3951,4325,4248,3714],0); -ELEMENTS[21576] = Fluid3D([4407,3951,4248,4068],0); -ELEMENTS[21577] = Fluid3D([4407,3951,4068,4103],0); -ELEMENTS[21578] = Fluid3D([4248,4407,4068,4528],0); -ELEMENTS[21579] = Fluid3D([4068,4248,4528,3900],0); -ELEMENTS[21580] = Fluid3D([3951,4248,4068,3774],0); -ELEMENTS[21581] = Fluid3D([3951,4248,3774,3714],0); -ELEMENTS[21582] = Fluid3D([3774,3951,3714,3310],0); -ELEMENTS[21583] = Fluid3D([4248,3774,3714,3900],0); -ELEMENTS[21584] = Fluid3D([3774,3714,3900,3486],0); -ELEMENTS[21585] = Fluid3D([3774,3714,3486,3310],0); -ELEMENTS[21586] = Fluid3D([3900,3774,3486,3843],0); -ELEMENTS[21587] = Fluid3D([4068,3951,3774,3607],0); -ELEMENTS[21588] = Fluid3D([3951,3774,3607,3310],0); -ELEMENTS[21589] = Fluid3D([4248,4068,3774,3900],0); -ELEMENTS[21590] = Fluid3D([3486,3774,3310,3607],0); -ELEMENTS[21591] = Fluid3D([3486,3774,3607,3843],0); -ELEMENTS[21592] = Fluid3D([4068,3951,3607,3857],0); -ELEMENTS[21593] = Fluid3D([3951,3607,3857,3604],0); -ELEMENTS[21594] = Fluid3D([3857,3951,3604,4103],0); -ELEMENTS[21595] = Fluid3D([4068,3951,3857,4103],0); -ELEMENTS[21596] = Fluid3D([3607,4068,3857,3907],0); -ELEMENTS[21597] = Fluid3D([3607,3857,3604,3574],0); -ELEMENTS[21598] = Fluid3D([3857,3604,3574,4103],0); -ELEMENTS[21599] = Fluid3D([3604,3607,3574,3227],0); -ELEMENTS[21600] = Fluid3D([3604,3607,3227,3310],0); -ELEMENTS[21601] = Fluid3D([3607,3857,3574,3907],0); -ELEMENTS[21602] = Fluid3D([3857,3574,3907,4103],0); -ELEMENTS[21603] = Fluid3D([3907,3857,4103,4068],0); -ELEMENTS[21604] = Fluid3D([3574,3604,3227,3298],0); -ELEMENTS[21605] = Fluid3D([3574,3604,3298,3745],0); -ELEMENTS[21606] = Fluid3D([3298,3574,3745,3403],0); -ELEMENTS[21607] = Fluid3D([3227,3574,3298,3023],0); -ELEMENTS[21608] = Fluid3D([3574,3604,3745,4103],0); -ELEMENTS[21609] = Fluid3D([3604,3227,3298,3226],0); -ELEMENTS[21610] = Fluid3D([3604,3227,3226,3310],0); -ELEMENTS[21611] = Fluid3D([3227,3298,3226,2895],0); -ELEMENTS[21612] = Fluid3D([3226,3227,2895,2965],0); -ELEMENTS[21613] = Fluid3D([3227,2895,2965,2784],0); -ELEMENTS[21614] = Fluid3D([2895,3226,2965,2838],0); -ELEMENTS[21615] = Fluid3D([3226,3227,2965,3310],0); -ELEMENTS[21616] = Fluid3D([2965,2895,2838,2655],0); -ELEMENTS[21617] = Fluid3D([2965,2895,2655,2784],0); -ELEMENTS[21618] = Fluid3D([2895,2838,2655,2548],0); -ELEMENTS[21619] = Fluid3D([3227,3298,2895,3023],0); -ELEMENTS[21620] = Fluid3D([3298,3226,2895,3076],0); -ELEMENTS[21621] = Fluid3D([2895,3298,3076,2993],0); -ELEMENTS[21622] = Fluid3D([3298,3226,3076,3503],0); -ELEMENTS[21623] = Fluid3D([3226,2895,3076,2838],0); -ELEMENTS[21624] = Fluid3D([3298,3604,3226,3503],0); -ELEMENTS[21625] = Fluid3D([2895,3298,2993,3023],0); -ELEMENTS[21626] = Fluid3D([3298,2993,3023,3403],0); -ELEMENTS[21627] = Fluid3D([2993,2895,3023,2674],0); -ELEMENTS[21628] = Fluid3D([3023,2993,2674,2831],0); -ELEMENTS[21629] = Fluid3D([3023,2993,2831,3128],0); -ELEMENTS[21630] = Fluid3D([2993,2674,2831,2710],0); -ELEMENTS[21631] = Fluid3D([2993,2674,2710,2808],0); -ELEMENTS[21632] = Fluid3D([2993,2674,2808,2895],0); -ELEMENTS[21633] = Fluid3D([2808,2993,2895,3076],0); -ELEMENTS[21634] = Fluid3D([2895,2808,3076,2838],0); -ELEMENTS[21635] = Fluid3D([2895,2808,2838,2548],0); -ELEMENTS[21636] = Fluid3D([2808,2838,2548,2812],0); -ELEMENTS[21637] = Fluid3D([2548,2808,2812,2710],0); -ELEMENTS[21638] = Fluid3D([2808,2838,2812,3076],0); -ELEMENTS[21639] = Fluid3D([2812,2808,3076,2710],0); -ELEMENTS[21640] = Fluid3D([2808,2993,3076,2710],0); -ELEMENTS[21641] = Fluid3D([2674,2808,2895,2548],0); -ELEMENTS[21642] = Fluid3D([2831,2993,2710,3128],0); -ELEMENTS[21643] = Fluid3D([2674,3023,2831,2803],0); -ELEMENTS[21644] = Fluid3D([2674,2710,2808,2548],0); -ELEMENTS[21645] = Fluid3D([2674,2831,2710,2507],0); -ELEMENTS[21646] = Fluid3D([2710,2674,2507,2391],0); -ELEMENTS[21647] = Fluid3D([2831,2710,2507,2590],0); -ELEMENTS[21648] = Fluid3D([2674,2831,2507,2803],0); -ELEMENTS[21649] = Fluid3D([3298,3076,2993,3159],0); -ELEMENTS[21650] = Fluid3D([3076,2993,3159,2710],0); -ELEMENTS[21651] = Fluid3D([3607,3574,3227,3296],0); -ELEMENTS[21652] = Fluid3D([3227,3607,3296,3109],0); -ELEMENTS[21653] = Fluid3D([3607,3574,3296,3851],0); -ELEMENTS[21654] = Fluid3D([3574,3227,3296,3307],0); -ELEMENTS[21655] = Fluid3D([3296,3574,3307,3634],0); -ELEMENTS[21656] = Fluid3D([3574,3307,3634,3907],0); -ELEMENTS[21657] = Fluid3D([3634,3574,3907,3851],0); -ELEMENTS[21658] = Fluid3D([3907,3634,3851,4072],0); -ELEMENTS[21659] = Fluid3D([3907,3634,4072,3681],0); -ELEMENTS[21660] = Fluid3D([3907,3634,3681,3307],0); -ELEMENTS[21661] = Fluid3D([3634,4072,3681,3851],0); -ELEMENTS[21662] = Fluid3D([3681,3634,3851,3441],0); -ELEMENTS[21663] = Fluid3D([3681,3634,3441,3307],0); -ELEMENTS[21664] = Fluid3D([3634,3851,3441,3296],0); -ELEMENTS[21665] = Fluid3D([3441,3634,3296,3307],0); -ELEMENTS[21666] = Fluid3D([3296,3574,3634,3851],0); -ELEMENTS[21667] = Fluid3D([3774,4068,3607,3843],0); -ELEMENTS[21668] = Fluid3D([3951,3607,3604,3310],0); -ELEMENTS[21669] = Fluid3D([3604,3298,3745,3503],0); -ELEMENTS[21670] = Fluid3D([4393,4067,4225,3881],0); -ELEMENTS[21671] = Fluid3D([4825,4888,5286,5548],0); -ELEMENTS[21672] = Fluid3D([4325,3951,3881,3714],0); -ELEMENTS[21673] = Fluid3D([5315,4724,5237,5195],0); -ELEMENTS[21674] = Fluid3D([4853,5054,4482,5194],0); -ELEMENTS[21675] = Fluid3D([4853,5054,5194,5075],0); -ELEMENTS[21676] = Fluid3D([5208,5129,5194,4646],0); -ELEMENTS[21677] = Fluid3D([5936,5703,5764,6556],0); -ELEMENTS[21678] = Fluid3D([3569,3460,3154,3527],0); -ELEMENTS[21679] = Fluid3D([3154,3569,3527,3353],0); -ELEMENTS[21680] = Fluid3D([3569,3527,3353,3910],0); -ELEMENTS[21681] = Fluid3D([3154,3569,3353,3342],0); -ELEMENTS[21682] = Fluid3D([3569,3353,3342,3418],0); -ELEMENTS[21683] = Fluid3D([3569,3527,3910,3862],0); -ELEMENTS[21684] = Fluid3D([3569,3527,3862,3460],0); -ELEMENTS[21685] = Fluid3D([3353,3342,3418,3007],0); -ELEMENTS[21686] = Fluid3D([3342,3418,3007,3096],0); -ELEMENTS[21687] = Fluid3D([3342,3418,3096,3138],0); -ELEMENTS[21688] = Fluid3D([3007,3342,3096,3103],0); -ELEMENTS[21689] = Fluid3D([3353,3342,3007,3154],0); -ELEMENTS[21690] = Fluid3D([3342,3007,3154,3103],0); -ELEMENTS[21691] = Fluid3D([3007,3353,3154,2944],0); -ELEMENTS[21692] = Fluid3D([3418,3007,3096,3060],0); -ELEMENTS[21693] = Fluid3D([3096,3418,3060,3138],0); -ELEMENTS[21694] = Fluid3D([3353,3154,2944,3446],0); -ELEMENTS[21695] = Fluid3D([3527,3910,3862,3919],0); -ELEMENTS[21696] = Fluid3D([3910,3862,3919,4175],0); -ELEMENTS[21697] = Fluid3D([3862,3919,4175,4441],0); -ELEMENTS[21698] = Fluid3D([3154,3007,2944,2855],0); -ELEMENTS[21699] = Fluid3D([3007,3353,2944,3190],0); -ELEMENTS[21700] = Fluid3D([2944,3353,3446,3273],0); -ELEMENTS[21701] = Fluid3D([5276,5770,5942,5559],0); -ELEMENTS[21702] = Fluid3D([5276,5770,5559,5089],0); -ELEMENTS[21703] = Fluid3D([5770,5942,5559,5788],0); -ELEMENTS[21704] = Fluid3D([5559,5770,5788,5504],0); -ELEMENTS[21705] = Fluid3D([5770,5788,5504,6012],0); -ELEMENTS[21706] = Fluid3D([5770,5788,6012,6467],0); -ELEMENTS[21707] = Fluid3D([5788,6012,6467,6035],0); -ELEMENTS[21708] = Fluid3D([6012,6467,6035,6348],0); -ELEMENTS[21709] = Fluid3D([6035,6012,6348,5658],0); -ELEMENTS[21710] = Fluid3D([6035,6012,5658,5381],0); -ELEMENTS[21711] = Fluid3D([6035,6012,5381,5788],0); -ELEMENTS[21712] = Fluid3D([6012,5770,6467,6043],0); -ELEMENTS[21713] = Fluid3D([5504,5770,6012,5700],0); -ELEMENTS[21714] = Fluid3D([5942,5276,5559,5272],0); -ELEMENTS[21715] = Fluid3D([5559,5942,5272,5797],0); -ELEMENTS[21716] = Fluid3D([5272,5559,5797,5200],0); -ELEMENTS[21717] = Fluid3D([5272,5559,5200,4753],0); -ELEMENTS[21718] = Fluid3D([5788,5559,5504,5453],0); -ELEMENTS[21719] = Fluid3D([5559,5504,5453,4996],0); -ELEMENTS[21720] = Fluid3D([5504,5453,4996,5213],0); -ELEMENTS[21721] = Fluid3D([5453,4996,5213,4872],0); -ELEMENTS[21722] = Fluid3D([5213,5453,4872,5346],0); -ELEMENTS[21723] = Fluid3D([5213,5453,5346,5835],0); -ELEMENTS[21724] = Fluid3D([5453,5346,5835,5661],0); -ELEMENTS[21725] = Fluid3D([4996,5213,4872,4602],0); -ELEMENTS[21726] = Fluid3D([4996,5504,5213,5381],0); -ELEMENTS[21727] = Fluid3D([4996,5504,5381,5089],0); -ELEMENTS[21728] = Fluid3D([4996,5504,5089,5559],0); -ELEMENTS[21729] = Fluid3D([5504,5381,5089,5700],0); -ELEMENTS[21730] = Fluid3D([5213,4996,5381,5292],0); -ELEMENTS[21731] = Fluid3D([4996,5213,4602,5292],0); -ELEMENTS[21732] = Fluid3D([4872,5213,5346,4757],0); -ELEMENTS[21733] = Fluid3D([5213,5453,5835,5788],0); -ELEMENTS[21734] = Fluid3D([5346,5213,5835,5542],0); -ELEMENTS[21735] = Fluid3D([5835,5346,5542,5878],0); -ELEMENTS[21736] = Fluid3D([5504,5453,5213,5788],0); -ELEMENTS[21737] = Fluid3D([4872,5213,4757,4602],0); -ELEMENTS[21738] = Fluid3D([5504,5213,5381,5788],0); -ELEMENTS[21739] = Fluid3D([5453,4872,5346,5410],0); -ELEMENTS[21740] = Fluid3D([5346,5453,5410,5661],0); -ELEMENTS[21741] = Fluid3D([4872,5346,5410,5021],0); -ELEMENTS[21742] = Fluid3D([5346,5410,5021,5661],0); -ELEMENTS[21743] = Fluid3D([5410,5021,5661,5268],0); -ELEMENTS[21744] = Fluid3D([5410,5021,5268,4500],0); -ELEMENTS[21745] = Fluid3D([5021,5661,5268,4898],0); -ELEMENTS[21746] = Fluid3D([5268,5021,4898,4500],0); -ELEMENTS[21747] = Fluid3D([5410,4872,5021,4500],0); -ELEMENTS[21748] = Fluid3D([5661,5410,5268,5781],0); -ELEMENTS[21749] = Fluid3D([5410,5268,5781,5283],0); -ELEMENTS[21750] = Fluid3D([5268,5781,5283,6080],0); -ELEMENTS[21751] = Fluid3D([5781,5283,6080,5921],0); -ELEMENTS[21752] = Fluid3D([6080,5781,5921,6161],0); -ELEMENTS[21753] = Fluid3D([5268,5781,6080,5661],0); -ELEMENTS[21754] = Fluid3D([5283,5268,6080,5547],0); -ELEMENTS[21755] = Fluid3D([5283,5268,5547,5094],0); -ELEMENTS[21756] = Fluid3D([5283,5268,5094,4531],0); -ELEMENTS[21757] = Fluid3D([5268,5547,5094,4898],0); -ELEMENTS[21758] = Fluid3D([5268,5547,4898,5661],0); -ELEMENTS[21759] = Fluid3D([5268,5547,5661,6080],0); -ELEMENTS[21760] = Fluid3D([5094,5268,4898,4531],0); -ELEMENTS[21761] = Fluid3D([5410,5268,5283,4857],0); -ELEMENTS[21762] = Fluid3D([5268,5283,4857,4531],0); -ELEMENTS[21763] = Fluid3D([5410,5268,4857,4500],0); -ELEMENTS[21764] = Fluid3D([5268,4857,4500,4531],0); -ELEMENTS[21765] = Fluid3D([4857,4500,4531,4241],0); -ELEMENTS[21766] = Fluid3D([4857,4500,4241,4583],0); -ELEMENTS[21767] = Fluid3D([5661,5410,5781,6297],0); -ELEMENTS[21768] = Fluid3D([5021,5346,5661,5256],0); -ELEMENTS[21769] = Fluid3D([5661,5021,5256,5574],0); -ELEMENTS[21770] = Fluid3D([5453,4872,5410,5200],0); -ELEMENTS[21771] = Fluid3D([5788,5559,5453,6161],0); -ELEMENTS[21772] = Fluid3D([5021,5346,5256,4776],0); -ELEMENTS[21773] = Fluid3D([5256,5021,4776,4734],0); -ELEMENTS[21774] = Fluid3D([5021,5346,4776,4872],0); -ELEMENTS[21775] = Fluid3D([5346,5213,5542,4757],0); -ELEMENTS[21776] = Fluid3D([5559,5942,5797,6207],0); -ELEMENTS[21777] = Fluid3D([5559,5942,6207,5788],0); -ELEMENTS[21778] = Fluid3D([6207,5559,5788,6161],0); -ELEMENTS[21779] = Fluid3D([5788,6207,6161,6905],0); -ELEMENTS[21780] = Fluid3D([5788,6207,6905,6467],0); -ELEMENTS[21781] = Fluid3D([6207,6161,6905,6889],0); -ELEMENTS[21782] = Fluid3D([5788,6207,6467,5770],0); -ELEMENTS[21783] = Fluid3D([5788,6207,5770,5942],0); -ELEMENTS[21784] = Fluid3D([5797,5559,6207,6161],0); -ELEMENTS[21785] = Fluid3D([6207,5797,6161,6418],0); -ELEMENTS[21786] = Fluid3D([6161,6207,6418,6889],0); -ELEMENTS[21787] = Fluid3D([6418,6161,6889,6629],0); -ELEMENTS[21788] = Fluid3D([6889,6418,6629,6994],0); -ELEMENTS[21789] = Fluid3D([6889,6418,6994,7058],0); -ELEMENTS[21790] = Fluid3D([6889,6418,7058,6939],0); -ELEMENTS[21791] = Fluid3D([6889,6418,6939,6207],0); -ELEMENTS[21792] = Fluid3D([6418,6939,6207,5942],0); -ELEMENTS[21793] = Fluid3D([5797,6161,6418,6629],0); -ELEMENTS[21794] = Fluid3D([6418,6629,6994,6201],0); -ELEMENTS[21795] = Fluid3D([6418,6994,7058,6493],0); -ELEMENTS[21796] = Fluid3D([6418,7058,6939,6471],0); -ELEMENTS[21797] = Fluid3D([7058,6889,6939,7288],0); -ELEMENTS[21798] = Fluid3D([6994,6889,7058,7648],0); -ELEMENTS[21799] = Fluid3D([6418,6629,6201,5797],0); -ELEMENTS[21800] = Fluid3D([6629,6889,6994,7196],0); -ELEMENTS[21801] = Fluid3D([6418,7058,6471,6493],0); -ELEMENTS[21802] = Fluid3D([6889,7058,7648,7288],0); -ELEMENTS[21803] = Fluid3D([6418,6994,6493,6201],0); -ELEMENTS[21804] = Fluid3D([6493,6418,6201,5942],0); -ELEMENTS[21805] = Fluid3D([6939,6418,6471,5942],0); -ELEMENTS[21806] = Fluid3D([6418,6471,5942,6493],0); -ELEMENTS[21807] = Fluid3D([6889,6939,7288,6905],0); -ELEMENTS[21808] = Fluid3D([6889,6939,6905,6207],0); -ELEMENTS[21809] = Fluid3D([6939,6905,6207,6467],0); -ELEMENTS[21810] = Fluid3D([6939,6905,6467,7288],0); -ELEMENTS[21811] = Fluid3D([6207,6939,6467,6715],0); -ELEMENTS[21812] = Fluid3D([6939,6467,6715,7780],0); -ELEMENTS[21813] = Fluid3D([6994,6889,7648,7196],0); -ELEMENTS[21814] = Fluid3D([6629,6889,7196,6976],0); -ELEMENTS[21815] = Fluid3D([7648,6889,7288,7882],0); -ELEMENTS[21816] = Fluid3D([6471,5942,6493,6020],0); -ELEMENTS[21817] = Fluid3D([6471,5942,6020,5936],0); -ELEMENTS[21818] = Fluid3D([6020,6471,5936,6556],0); -ELEMENTS[21819] = Fluid3D([6471,5942,5936,6715],0); -ELEMENTS[21820] = Fluid3D([5942,6020,5936,5513],0); -ELEMENTS[21821] = Fluid3D([6020,5936,5513,5764],0); -ELEMENTS[21822] = Fluid3D([6020,5936,5764,6556],0); -ELEMENTS[21823] = Fluid3D([5513,6020,5764,6005],0); -ELEMENTS[21824] = Fluid3D([5942,6020,5513,5909],0); -ELEMENTS[21825] = Fluid3D([6020,5513,5909,5685],0); -ELEMENTS[21826] = Fluid3D([5513,5909,5685,5284],0); -ELEMENTS[21827] = Fluid3D([5909,5685,5284,5688],0); -ELEMENTS[21828] = Fluid3D([6994,6493,6201,6745],0); -ELEMENTS[21829] = Fluid3D([6493,6201,6745,5909],0); -ELEMENTS[21830] = Fluid3D([6493,6201,5909,5942],0); -ELEMENTS[21831] = Fluid3D([6889,7648,7196,8289],0); -ELEMENTS[21832] = Fluid3D([7058,6471,6493,6869],0); -ELEMENTS[21833] = Fluid3D([6493,6471,6020,6869],0); -ELEMENTS[21834] = Fluid3D([6207,5797,6418,5942],0); -ELEMENTS[21835] = Fluid3D([6161,6889,6629,6976],0); -ELEMENTS[21836] = Fluid3D([7058,7648,7288,7780],0); -ELEMENTS[21837] = Fluid3D([7288,7058,7780,6939],0); -ELEMENTS[21838] = Fluid3D([5513,5909,5284,5272],0); -ELEMENTS[21839] = Fluid3D([6201,6994,6745,6375],0); -ELEMENTS[21840] = Fluid3D([6629,6994,6201,6375],0); -ELEMENTS[21841] = Fluid3D([7058,6994,7648,7431],0); -ELEMENTS[21842] = Fluid3D([7648,7058,7431,7908],0); -ELEMENTS[21843] = Fluid3D([7648,7058,7908,7780],0); -ELEMENTS[21844] = Fluid3D([7058,7908,7780,7109],0); -ELEMENTS[21845] = Fluid3D([6994,7648,7431,7971],0); -ELEMENTS[21846] = Fluid3D([7431,7648,7908,8132],0); -ELEMENTS[21847] = Fluid3D([7908,7431,8132,7712],0); -ELEMENTS[21848] = Fluid3D([7058,6939,6471,7109],0); -ELEMENTS[21849] = Fluid3D([6493,7058,6869,7431],0); -ELEMENTS[21850] = Fluid3D([7648,6994,7196,7971],0); -ELEMENTS[21851] = Fluid3D([6994,7058,6493,7431],0); -ELEMENTS[21852] = Fluid3D([7058,6471,6869,7109],0); -ELEMENTS[21853] = Fluid3D([6869,7058,7109,7908],0); -ELEMENTS[21854] = Fluid3D([6471,6869,7109,6556],0); -ELEMENTS[21855] = Fluid3D([6994,6629,7196,7264],0); -ELEMENTS[21856] = Fluid3D([6994,6493,6745,7431],0); -ELEMENTS[21857] = Fluid3D([6471,6020,6869,6556],0); -ELEMENTS[21858] = Fluid3D([7058,7431,7908,6869],0); -ELEMENTS[21859] = Fluid3D([7288,6889,6905,7882],0); -ELEMENTS[21860] = Fluid3D([5942,6020,5909,6493],0); -ELEMENTS[21861] = Fluid3D([6020,5909,6493,6314],0); -ELEMENTS[21862] = Fluid3D([5942,5276,5272,5513],0); -ELEMENTS[21863] = Fluid3D([5797,5272,5200,5393],0); -ELEMENTS[21864] = Fluid3D([5272,5200,5393,4774],0); -ELEMENTS[21865] = Fluid3D([5200,5797,5393,5781],0); -ELEMENTS[21866] = Fluid3D([5393,5272,4774,5284],0); -ELEMENTS[21867] = Fluid3D([5797,5272,5393,5909],0); -ELEMENTS[21868] = Fluid3D([5272,5200,4774,4753],0); -ELEMENTS[21869] = Fluid3D([5200,5393,4774,4986],0); -ELEMENTS[21870] = Fluid3D([5200,5393,4986,5283],0); -ELEMENTS[21871] = Fluid3D([4774,5200,4986,4583],0); -ELEMENTS[21872] = Fluid3D([5393,4774,4986,4896],0); -ELEMENTS[21873] = Fluid3D([4986,5393,4896,5384],0); -ELEMENTS[21874] = Fluid3D([4986,5393,5384,5283],0); -ELEMENTS[21875] = Fluid3D([5384,4986,5283,5302],0); -ELEMENTS[21876] = Fluid3D([5283,5384,5302,5980],0); -ELEMENTS[21877] = Fluid3D([5384,5302,5980,5549],0); -ELEMENTS[21878] = Fluid3D([5384,5302,5549,4935],0); -ELEMENTS[21879] = Fluid3D([4896,4986,5384,4775],0); -ELEMENTS[21880] = Fluid3D([4896,4986,4775,4241],0); -ELEMENTS[21881] = Fluid3D([5393,4774,4896,5284],0); -ELEMENTS[21882] = Fluid3D([5384,5302,4935,4775],0); -ELEMENTS[21883] = Fluid3D([5384,5302,4775,4986],0); -ELEMENTS[21884] = Fluid3D([5302,4935,4775,4883],0); -ELEMENTS[21885] = Fluid3D([4774,4986,4896,4241],0); -ELEMENTS[21886] = Fluid3D([5393,4896,5384,5643],0); -ELEMENTS[21887] = Fluid3D([5384,4896,4775,4935],0); -ELEMENTS[21888] = Fluid3D([7431,7648,8132,8650],0); -ELEMENTS[21889] = Fluid3D([8132,7431,8650,7578],0); -ELEMENTS[21890] = Fluid3D([5559,5770,5504,5089],0); -ELEMENTS[21891] = Fluid3D([5770,5504,5089,5700],0); -ELEMENTS[21892] = Fluid3D([5276,5559,5272,4753],0); -ELEMENTS[21893] = Fluid3D([5559,5797,5200,5453],0); -ELEMENTS[21894] = Fluid3D([5256,5661,5574,5878],0); -ELEMENTS[21895] = Fluid3D([5256,5661,5878,5346],0); -ELEMENTS[21896] = Fluid3D([5574,5256,5878,5756],0); -ELEMENTS[21897] = Fluid3D([5788,5504,6012,5381],0); -ELEMENTS[21898] = Fluid3D([5942,5272,5797,5909],0); -ELEMENTS[21899] = Fluid3D([3777,3460,3569,3862],0); -ELEMENTS[21900] = Fluid3D([6720,6466,6249,5944],0); -ELEMENTS[21901] = Fluid3D([4262,4623,4805,4915],0); -ELEMENTS[21902] = Fluid3D([4623,4805,4915,5186],0); -ELEMENTS[21903] = Fluid3D([4915,4623,5186,4711],0); -ELEMENTS[21904] = Fluid3D([4805,4262,4915,4495],0); -ELEMENTS[21905] = Fluid3D([4915,4805,4495,5043],0); -ELEMENTS[21906] = Fluid3D([4915,4805,5043,5498],0); -ELEMENTS[21907] = Fluid3D([4915,4805,5498,5186],0); -ELEMENTS[21908] = Fluid3D([3471,3924,3619,3817],0); -ELEMENTS[21909] = Fluid3D([5414,5856,5218,5445],0); -ELEMENTS[21910] = Fluid3D([5237,4724,4767,4638],0); -ELEMENTS[21911] = Fluid3D([4767,5237,4638,5276],0); -ELEMENTS[21912] = Fluid3D([4724,4767,4638,4351],0); -ELEMENTS[21913] = Fluid3D([4724,4767,4351,4569],0); -ELEMENTS[21914] = Fluid3D([5237,4724,4638,5195],0); -ELEMENTS[21915] = Fluid3D([4638,4724,4351,4425],0); -ELEMENTS[21916] = Fluid3D([4767,4638,4351,4753],0); -ELEMENTS[21917] = Fluid3D([5702,5057,5379,5799],0); -ELEMENTS[21918] = Fluid3D([5379,5702,5799,6293],0); -ELEMENTS[21919] = Fluid3D([4821,5420,5242,5208],0); -ELEMENTS[21920] = Fluid3D([4392,4103,3989,4482],0); -ELEMENTS[21921] = Fluid3D([5276,5399,5770,5089],0); -ELEMENTS[21922] = Fluid3D([5856,6105,5679,6304],0); -ELEMENTS[21923] = Fluid3D([5679,5856,6304,5793],0); -ELEMENTS[21924] = Fluid3D([5856,6304,5793,6054],0); -ELEMENTS[21925] = Fluid3D([5856,6105,6304,6576],0); -ELEMENTS[21926] = Fluid3D([5793,5856,6054,5218],0); -ELEMENTS[21927] = Fluid3D([5679,5856,5793,5218],0); -ELEMENTS[21928] = Fluid3D([6105,5679,6304,6198],0); -ELEMENTS[21929] = Fluid3D([6105,5679,6198,5648],0); -ELEMENTS[21930] = Fluid3D([5679,6304,6198,6017],0); -ELEMENTS[21931] = Fluid3D([6304,6105,6198,6872],0); -ELEMENTS[21932] = Fluid3D([6105,6198,6872,6657],0); -ELEMENTS[21933] = Fluid3D([6872,6105,6657,6576],0); -ELEMENTS[21934] = Fluid3D([6304,6105,6872,6576],0); -ELEMENTS[21935] = Fluid3D([6304,6198,6017,6777],0); -ELEMENTS[21936] = Fluid3D([6017,6304,6777,6961],0); -ELEMENTS[21937] = Fluid3D([6198,6017,6777,6729],0); -ELEMENTS[21938] = Fluid3D([6304,6198,6777,6872],0); -ELEMENTS[21939] = Fluid3D([6304,5679,5793,6017],0); -ELEMENTS[21940] = Fluid3D([6198,5679,6017,5627],0); -ELEMENTS[21941] = Fluid3D([5679,6017,5627,5670],0); -ELEMENTS[21942] = Fluid3D([6017,5627,5670,5819],0); -ELEMENTS[21943] = Fluid3D([6017,5627,5819,6103],0); -ELEMENTS[21944] = Fluid3D([4569,4817,4231,4724],0); -ELEMENTS[21945] = Fluid3D([5513,5764,5195,6005],0); -ELEMENTS[21946] = Fluid3D([5321,5114,4873,4565],0); -ELEMENTS[21947] = Fluid3D([4218,4514,4757,4306],0); -ELEMENTS[21948] = Fluid3D([4062,4502,4069,4231],0); -ELEMENTS[21949] = Fluid3D([5366,5064,4802,5511],0); -ELEMENTS[21950] = Fluid3D([5321,5388,4842,5379],0); -ELEMENTS[21951] = Fluid3D([4853,4482,4301,4471],0); -ELEMENTS[21952] = Fluid3D([5208,5194,5670,5320],0); -ELEMENTS[21953] = Fluid3D([6029,5687,6492,5784],0); -ELEMENTS[21954] = Fluid3D([4623,4262,4164,4528],0); -ELEMENTS[21955] = Fluid3D([4602,4218,4757,4525],0); -ELEMENTS[21956] = Fluid3D([7674,6853,7141,6725],0); -ELEMENTS[21957] = Fluid3D([3907,4072,4116,3681],0); -ELEMENTS[21958] = Fluid3D([7460,8230,8091,8415],0); -ELEMENTS[21959] = Fluid3D([8670,9310,9611,9455],0); -ELEMENTS[21960] = Fluid3D([9611,8670,9455,9146],0); -ELEMENTS[21961] = Fluid3D([8670,9455,9146,8524],0); -ELEMENTS[21962] = Fluid3D([8670,9455,8524,8302],0); -ELEMENTS[21963] = Fluid3D([9455,9146,8524,8834],0); -ELEMENTS[21964] = Fluid3D([9146,8524,8834,8387],0); -ELEMENTS[21965] = Fluid3D([8670,9310,9455,8302],0); -ELEMENTS[21966] = Fluid3D([9146,8670,8524,8387],0); -ELEMENTS[21967] = Fluid3D([9310,9611,9455,10222],0); -ELEMENTS[21968] = Fluid3D([9611,9455,10222,10180],0); -ELEMENTS[21969] = Fluid3D([9455,10222,10180,10148],0); -ELEMENTS[21970] = Fluid3D([9310,9611,10222,10437],0); -ELEMENTS[21971] = Fluid3D([10222,10180,10148,11201],0); -ELEMENTS[21972] = Fluid3D([9455,9310,10222,9216],0); -ELEMENTS[21973] = Fluid3D([9455,10222,10148,9216],0); -ELEMENTS[21974] = Fluid3D([9611,9455,10180,9146],0); -ELEMENTS[21975] = Fluid3D([9611,8670,9146,8778],0); -ELEMENTS[21976] = Fluid3D([10180,9455,10148,9687],0); -ELEMENTS[21977] = Fluid3D([10180,9455,9687,9146],0); -ELEMENTS[21978] = Fluid3D([10148,10180,9687,10728],0); -ELEMENTS[21979] = Fluid3D([10180,9687,10728,9791],0); -ELEMENTS[21980] = Fluid3D([9455,10148,9687,9754],0); -ELEMENTS[21981] = Fluid3D([9455,10148,9754,9216],0); -ELEMENTS[21982] = Fluid3D([10148,9687,9754,10475],0); -ELEMENTS[21983] = Fluid3D([9754,10148,10475,11382],0); -ELEMENTS[21984] = Fluid3D([10148,10180,10728,11201],0); -ELEMENTS[21985] = Fluid3D([10728,10148,11201,10475],0); -ELEMENTS[21986] = Fluid3D([9687,10148,10728,10475],0); -ELEMENTS[21987] = Fluid3D([10222,9611,10180,10619],0); -ELEMENTS[21988] = Fluid3D([10222,9611,10619,10437],0); -ELEMENTS[21989] = Fluid3D([9611,10180,10619,10040],0); -ELEMENTS[21990] = Fluid3D([10619,9611,10040,9814],0); -ELEMENTS[21991] = Fluid3D([9611,10180,10040,9146],0); -ELEMENTS[21992] = Fluid3D([10180,10222,10619,11102],0); -ELEMENTS[21993] = Fluid3D([10180,10222,11102,11201],0); -ELEMENTS[21994] = Fluid3D([10619,10180,11102,11513],0); -ELEMENTS[21995] = Fluid3D([10222,10619,11102,11021],0); -ELEMENTS[21996] = Fluid3D([11102,10222,11021,10659],0); -ELEMENTS[21997] = Fluid3D([10180,10619,10040,11513],0); -ELEMENTS[21998] = Fluid3D([4072,4568,4296,4109],0); -ELEMENTS[21999] = Fluid3D([4439,4805,4940,4948],0); -ELEMENTS[22000] = Fluid3D([4805,4940,4948,5498],0); -ELEMENTS[22001] = Fluid3D([4439,4805,4948,4615],0); -ELEMENTS[22002] = Fluid3D([4940,4439,4948,4604],0); -ELEMENTS[22003] = Fluid3D([11666,12545,11612,12271],0); -ELEMENTS[22004] = Fluid3D([12119,12331,11917,13041],0); -ELEMENTS[22005] = Fluid3D([13325,13122,12524,13489],0); -ELEMENTS[22006] = Fluid3D([15286,15117,14699,14875],0); -ELEMENTS[22007] = Fluid3D([4153,4468,4566,4832],0); -ELEMENTS[22008] = Fluid3D([8019,7691,7716,8658],0); -ELEMENTS[22009] = Fluid3D([16231,16669,16661,16456],0); -ELEMENTS[22010] = Fluid3D([5306,5676,5812,5231],0); -ELEMENTS[22011] = Fluid3D([5812,5306,5231,5572],0); -ELEMENTS[22012] = Fluid3D([15913,16309,15927,16736],0); -ELEMENTS[22013] = Fluid3D([9560,8919,9206,9510],0); -ELEMENTS[22014] = Fluid3D([7664,8176,8462,7848],0); -ELEMENTS[22015] = Fluid3D([8176,8462,7848,8546],0); -ELEMENTS[22016] = Fluid3D([8176,8462,8546,8536],0); -ELEMENTS[22017] = Fluid3D([8462,7848,8546,8704],0); -ELEMENTS[22018] = Fluid3D([16565,16846,16315,16704],0); -ELEMENTS[22019] = Fluid3D([7114,7813,7161,7478],0); -ELEMENTS[22020] = Fluid3D([7114,7813,7478,7893],0); -ELEMENTS[22021] = Fluid3D([7813,7161,7478,8332],0); -ELEMENTS[22022] = Fluid3D([7161,7114,7478,6726],0); -ELEMENTS[22023] = Fluid3D([7161,7114,6726,6521],0); -ELEMENTS[22024] = Fluid3D([6726,7161,6521,6228],0); -ELEMENTS[22025] = Fluid3D([7478,7161,6726,7267],0); -ELEMENTS[22026] = Fluid3D([7161,6726,7267,6894],0); -ELEMENTS[22027] = Fluid3D([7478,7161,7267,7652],0); -ELEMENTS[22028] = Fluid3D([7161,7267,7652,6894],0); -ELEMENTS[22029] = Fluid3D([7267,7652,6894,7627],0); -ELEMENTS[22030] = Fluid3D([17527,17683,17708,17846],0); -ELEMENTS[22031] = Fluid3D([5595,6213,5701,5590],0); -ELEMENTS[22032] = Fluid3D([5830,5831,5278,5759],0); -ELEMENTS[22033] = Fluid3D([7777,8233,7511,7866],0); -ELEMENTS[22034] = Fluid3D([16712,16655,16348,16323],0); -ELEMENTS[22035] = Fluid3D([2776,3025,2881,3071],0); -ELEMENTS[22036] = Fluid3D([2776,3025,3071,2954],0); -ELEMENTS[22037] = Fluid3D([2881,2776,3071,2938],0); -ELEMENTS[22038] = Fluid3D([3025,2881,3071,3367],0); -ELEMENTS[22039] = Fluid3D([10959,10378,10338,9664],0); -ELEMENTS[22040] = Fluid3D([10378,10338,9664,10264],0); -ELEMENTS[22041] = Fluid3D([16215,16767,16488,16514],0); -ELEMENTS[22042] = Fluid3D([9676,9451,10273,10433],0); -ELEMENTS[22043] = Fluid3D([10273,9676,10433,10657],0); -ELEMENTS[22044] = Fluid3D([9676,9451,10433,9391],0); -ELEMENTS[22045] = Fluid3D([9676,9451,9391,8489],0); -ELEMENTS[22046] = Fluid3D([9676,10433,10657,10435],0); -ELEMENTS[22047] = Fluid3D([9676,10433,10435,9391],0); -ELEMENTS[22048] = Fluid3D([10657,9676,10435,10772],0); -ELEMENTS[22049] = Fluid3D([10435,10657,10772,11558],0); -ELEMENTS[22050] = Fluid3D([10657,10772,11558,10982],0); -ELEMENTS[22051] = Fluid3D([11558,10657,10982,10273],0); -ELEMENTS[22052] = Fluid3D([10657,9676,10772,10982],0); -ELEMENTS[22053] = Fluid3D([11558,10657,10273,10433],0); -ELEMENTS[22054] = Fluid3D([9451,10433,9391,9574],0); -ELEMENTS[22055] = Fluid3D([9391,9451,9574,8742],0); -ELEMENTS[22056] = Fluid3D([9451,10433,9574,10292],0); -ELEMENTS[22057] = Fluid3D([9451,10433,10292,10273],0); -ELEMENTS[22058] = Fluid3D([10433,10657,10435,11558],0); -ELEMENTS[22059] = Fluid3D([10433,9574,10292,10741],0); -ELEMENTS[22060] = Fluid3D([10433,9574,10741,10174],0); -ELEMENTS[22061] = Fluid3D([9574,10292,10741,10212],0); -ELEMENTS[22062] = Fluid3D([9574,10292,10212,9448],0); -ELEMENTS[22063] = Fluid3D([9574,10292,9448,9451],0); -ELEMENTS[22064] = Fluid3D([10741,10433,10174,11050],0); -ELEMENTS[22065] = Fluid3D([10741,10433,11050,11136],0); -ELEMENTS[22066] = Fluid3D([10212,9574,9448,9270],0); -ELEMENTS[22067] = Fluid3D([9574,9448,9270,8842],0); -ELEMENTS[22068] = Fluid3D([9574,9448,8842,8742],0); -ELEMENTS[22069] = Fluid3D([10212,9574,9270,10062],0); -ELEMENTS[22070] = Fluid3D([10174,10741,11050,11074],0); -ELEMENTS[22071] = Fluid3D([10741,11050,11074,12072],0); -ELEMENTS[22072] = Fluid3D([10174,10741,11074,10224],0); -ELEMENTS[22073] = Fluid3D([10174,10741,10224,9574],0); -ELEMENTS[22074] = Fluid3D([11074,10174,10224,10350],0); -ELEMENTS[22075] = Fluid3D([11074,10174,10350,10794],0); -ELEMENTS[22076] = Fluid3D([11074,10174,10794,11050],0); -ELEMENTS[22077] = Fluid3D([10224,11074,10350,10519],0); -ELEMENTS[22078] = Fluid3D([10350,10224,10519,9521],0); -ELEMENTS[22079] = Fluid3D([10224,11074,10519,11078],0); -ELEMENTS[22080] = Fluid3D([10519,10224,11078,10062],0); -ELEMENTS[22081] = Fluid3D([10519,10224,10062,9521],0); -ELEMENTS[22082] = Fluid3D([10224,11078,10062,10212],0); -ELEMENTS[22083] = Fluid3D([10224,11074,11078,10741],0); -ELEMENTS[22084] = Fluid3D([11078,10224,10741,10212],0); -ELEMENTS[22085] = Fluid3D([10292,10433,10741,11136],0); -ELEMENTS[22086] = Fluid3D([10433,9574,10174,9391],0); -ELEMENTS[22087] = Fluid3D([10741,9574,10212,10224],0); -ELEMENTS[22088] = Fluid3D([9448,9270,8842,8680],0); -ELEMENTS[22089] = Fluid3D([9448,9270,8680,9656],0); -ELEMENTS[22090] = Fluid3D([9270,8842,8680,8361],0); -ELEMENTS[22091] = Fluid3D([8680,9270,8361,8673],0); -ELEMENTS[22092] = Fluid3D([9270,8842,8361,8987],0); -ELEMENTS[22093] = Fluid3D([8361,8680,8673,7887],0); -ELEMENTS[22094] = Fluid3D([8361,8680,7887,7747],0); -ELEMENTS[22095] = Fluid3D([8361,8680,7747,8842],0); -ELEMENTS[22096] = Fluid3D([8361,9270,8987,9025],0); -ELEMENTS[22097] = Fluid3D([8680,9270,8673,9656],0); -ELEMENTS[22098] = Fluid3D([9270,8673,9656,9025],0); -ELEMENTS[22099] = Fluid3D([8673,9656,9025,8713],0); -ELEMENTS[22100] = Fluid3D([9025,8673,8713,8177],0); -ELEMENTS[22101] = Fluid3D([8673,9656,8713,9254],0); -ELEMENTS[22102] = Fluid3D([9270,8842,8987,9574],0); -ELEMENTS[22103] = Fluid3D([8842,9448,8680,8742],0); -ELEMENTS[22104] = Fluid3D([8680,7887,7747,7862],0); -ELEMENTS[22105] = Fluid3D([8680,7887,7862,8449],0); -ELEMENTS[22106] = Fluid3D([7747,8680,7862,8325],0); -ELEMENTS[22107] = Fluid3D([8680,7862,8325,8731],0); -ELEMENTS[22108] = Fluid3D([7887,7862,8449,7395],0); -ELEMENTS[22109] = Fluid3D([7887,7747,7862,7126],0); -ELEMENTS[22110] = Fluid3D([7887,7862,7395,7126],0); -ELEMENTS[22111] = Fluid3D([7887,7747,7126,7357],0); -ELEMENTS[22112] = Fluid3D([7887,7747,7357,8361],0); -ELEMENTS[22113] = Fluid3D([7747,7126,7357,6608],0); -ELEMENTS[22114] = Fluid3D([7747,8680,8325,8742],0); -ELEMENTS[22115] = Fluid3D([8680,7862,8731,8449],0); -ELEMENTS[22116] = Fluid3D([8449,7887,7395,7864],0); -ELEMENTS[22117] = Fluid3D([8449,7887,7864,8673],0); -ELEMENTS[22118] = Fluid3D([7887,7395,7864,7219],0); -ELEMENTS[22119] = Fluid3D([7887,7395,7219,7126],0); -ELEMENTS[22120] = Fluid3D([7864,7887,7219,8017],0); -ELEMENTS[22121] = Fluid3D([7864,7887,8017,8673],0); -ELEMENTS[22122] = Fluid3D([7887,7219,8017,7357],0); -ELEMENTS[22123] = Fluid3D([7395,8449,7864,8363],0); -ELEMENTS[22124] = Fluid3D([8449,7864,8363,8713],0); -ELEMENTS[22125] = Fluid3D([7864,8363,8713,7689],0); -ELEMENTS[22126] = Fluid3D([8713,7864,7689,8017],0); -ELEMENTS[22127] = Fluid3D([7864,7689,8017,7219],0); -ELEMENTS[22128] = Fluid3D([7864,7689,7219,7178],0); -ELEMENTS[22129] = Fluid3D([7864,7689,7178,7504],0); -ELEMENTS[22130] = Fluid3D([7178,7864,7504,7395],0); -ELEMENTS[22131] = Fluid3D([7689,7178,7504,6996],0); -ELEMENTS[22132] = Fluid3D([7178,7504,6996,6651],0); -ELEMENTS[22133] = Fluid3D([7689,7178,6996,7219],0); -ELEMENTS[22134] = Fluid3D([8449,7864,8713,8673],0); -ELEMENTS[22135] = Fluid3D([7864,8713,8673,8017],0); -ELEMENTS[22136] = Fluid3D([8713,8449,8673,9254],0); -ELEMENTS[22137] = Fluid3D([7689,8017,7219,7150],0); -ELEMENTS[22138] = Fluid3D([7504,7178,7395,6646],0); -ELEMENTS[22139] = Fluid3D([7504,7178,6646,6651],0); -ELEMENTS[22140] = Fluid3D([7219,7689,7150,6996],0); -ELEMENTS[22141] = Fluid3D([7689,8017,7150,8177],0); -ELEMENTS[22142] = Fluid3D([7689,8017,8177,8713],0); -ELEMENTS[22143] = Fluid3D([8017,7150,8177,7305],0); -ELEMENTS[22144] = Fluid3D([8017,8177,8713,8673],0); -ELEMENTS[22145] = Fluid3D([8017,8177,8673,8335],0); -ELEMENTS[22146] = Fluid3D([8017,8177,8335,7305],0); -ELEMENTS[22147] = Fluid3D([7178,7864,7395,7219],0); -ELEMENTS[22148] = Fluid3D([7864,8363,7689,7504],0); -ELEMENTS[22149] = Fluid3D([8017,7219,7150,7357],0); -ELEMENTS[22150] = Fluid3D([7178,7395,6646,7219],0); -ELEMENTS[22151] = Fluid3D([8680,7887,8449,8673],0); -ELEMENTS[22152] = Fluid3D([9270,8361,8673,9025],0); -ELEMENTS[22153] = Fluid3D([7862,8325,8731,8018],0); -ELEMENTS[22154] = Fluid3D([8731,7862,8018,8081],0); -ELEMENTS[22155] = Fluid3D([8325,8731,8018,8533],0); -ELEMENTS[22156] = Fluid3D([8018,8731,8081,8957],0); -ELEMENTS[22157] = Fluid3D([7862,8325,8018,7711],0); -ELEMENTS[22158] = Fluid3D([8731,7862,8081,8449],0); -ELEMENTS[22159] = Fluid3D([7862,8018,8081,7299],0); -ELEMENTS[22160] = Fluid3D([8081,7862,7299,7395],0); -ELEMENTS[22161] = Fluid3D([7862,8018,7299,7711],0); -ELEMENTS[22162] = Fluid3D([8018,8081,7299,7723],0); -ELEMENTS[22163] = Fluid3D([8842,8361,8987,8117],0); -ELEMENTS[22164] = Fluid3D([8842,8361,8117,7747],0); -ELEMENTS[22165] = Fluid3D([8361,8987,8117,8203],0); -ELEMENTS[22166] = Fluid3D([8117,8361,8203,7357],0); -ELEMENTS[22167] = Fluid3D([8361,8987,8203,8335],0); -ELEMENTS[22168] = Fluid3D([8203,8361,8335,7357],0); -ELEMENTS[22169] = Fluid3D([8987,8842,8117,8777],0); -ELEMENTS[22170] = Fluid3D([8987,8842,8777,9574],0); -ELEMENTS[22171] = Fluid3D([8842,8117,8777,8742],0); -ELEMENTS[22172] = Fluid3D([8842,8117,8742,7747],0); -ELEMENTS[22173] = Fluid3D([8777,8842,8742,9574],0); -ELEMENTS[22174] = Fluid3D([8742,8842,7747,8680],0); -ELEMENTS[22175] = Fluid3D([8117,8987,8777,8551],0); -ELEMENTS[22176] = Fluid3D([8777,8117,8551,7722],0); -ELEMENTS[22177] = Fluid3D([8117,8987,8551,8203],0); -ELEMENTS[22178] = Fluid3D([8987,8777,8551,9438],0); -ELEMENTS[22179] = Fluid3D([8987,8777,9438,9574],0); -ELEMENTS[22180] = Fluid3D([8777,8551,9438,8954],0); -ELEMENTS[22181] = Fluid3D([8777,8551,8954,7722],0); -ELEMENTS[22182] = Fluid3D([9438,8777,8954,9391],0); -ELEMENTS[22183] = Fluid3D([9438,8777,9391,9574],0); -ELEMENTS[22184] = Fluid3D([8777,8954,9391,8693],0); -ELEMENTS[22185] = Fluid3D([8777,9391,9574,8742],0); -ELEMENTS[22186] = Fluid3D([9391,8777,8693,7722],0); -ELEMENTS[22187] = Fluid3D([8777,8954,8693,7722],0); -ELEMENTS[22188] = Fluid3D([8777,9391,8742,7722],0); -ELEMENTS[22189] = Fluid3D([8954,9391,8693,9782],0); -ELEMENTS[22190] = Fluid3D([8693,8954,9782,9121],0); -ELEMENTS[22191] = Fluid3D([8693,8954,9121,8298],0); -ELEMENTS[22192] = Fluid3D([8693,8954,8298,7722],0); -ELEMENTS[22193] = Fluid3D([8954,9121,8298,8541],0); -ELEMENTS[22194] = Fluid3D([9121,8298,8541,8139],0); -ELEMENTS[22195] = Fluid3D([8954,9782,9121,9795],0); -ELEMENTS[22196] = Fluid3D([9121,8954,9795,8541],0); -ELEMENTS[22197] = Fluid3D([8298,8541,8139,7682],0); -ELEMENTS[22198] = Fluid3D([8298,8541,7682,8085],0); -ELEMENTS[22199] = Fluid3D([8139,8298,7682,7292],0); -ELEMENTS[22200] = Fluid3D([8298,8954,8541,8551],0); -ELEMENTS[22201] = Fluid3D([9121,8693,8298,9141],0); -ELEMENTS[22202] = Fluid3D([9782,9121,9795,9890],0); -ELEMENTS[22203] = Fluid3D([8551,9438,8954,9002],0); -ELEMENTS[22204] = Fluid3D([8551,8987,9438,9173],0); -ELEMENTS[22205] = Fluid3D([8987,9438,9173,10224],0); -ELEMENTS[22206] = Fluid3D([8551,8987,9173,8203],0); -ELEMENTS[22207] = Fluid3D([9438,8551,9173,9002],0); -ELEMENTS[22208] = Fluid3D([10273,9676,10657,10982],0); -ELEMENTS[22209] = Fluid3D([10433,10174,11050,10435],0); -ELEMENTS[22210] = Fluid3D([10350,11074,10794,10980],0); -ELEMENTS[22211] = Fluid3D([10292,10741,10212,11205],0); -ELEMENTS[22212] = Fluid3D([10292,10741,11205,11136],0); -ELEMENTS[22213] = Fluid3D([11205,10292,11136,10613],0); -ELEMENTS[22214] = Fluid3D([10292,11136,10613,10273],0); -ELEMENTS[22215] = Fluid3D([10212,10292,11205,10383],0); -ELEMENTS[22216] = Fluid3D([10212,10292,10383,9448],0); -ELEMENTS[22217] = Fluid3D([10741,10212,11205,11078],0); -ELEMENTS[22218] = Fluid3D([11205,10212,10383,10643],0); -ELEMENTS[22219] = Fluid3D([11205,10212,10643,11078],0); -ELEMENTS[22220] = Fluid3D([10212,10383,10643,9656],0); -ELEMENTS[22221] = Fluid3D([10292,11205,10383,10613],0); -ELEMENTS[22222] = Fluid3D([9448,10212,9270,9656],0); -ELEMENTS[22223] = Fluid3D([7126,7887,7357,7219],0); -ELEMENTS[22224] = Fluid3D([8325,8680,8731,9448],0); -ELEMENTS[22225] = Fluid3D([10174,10224,10350,9438],0); -ELEMENTS[22226] = Fluid3D([10350,10174,9438,10794],0); -ELEMENTS[22227] = Fluid3D([7862,7747,8325,7711],0); -ELEMENTS[22228] = Fluid3D([7747,8325,7711,8742],0); -ELEMENTS[22229] = Fluid3D([8325,7711,8742,8532],0); -ELEMENTS[22230] = Fluid3D([8325,7711,8532,8533],0); -ELEMENTS[22231] = Fluid3D([8742,8325,8532,9451],0); -ELEMENTS[22232] = Fluid3D([7747,7862,7126,7711],0); -ELEMENTS[22233] = Fluid3D([8673,8361,7887,8017],0); -ELEMENTS[22234] = Fluid3D([7862,8449,7395,8081],0); -ELEMENTS[22235] = Fluid3D([9572,9689,10116,10429],0); -ELEMENTS[22236] = Fluid3D([15780,16349,15974,15566],0); -ELEMENTS[22237] = Fluid3D([15810,15527,16020,15528],0); -ELEMENTS[22238] = Fluid3D([15810,15527,15528,15002],0); -ELEMENTS[22239] = Fluid3D([15527,16020,15528,15692],0); -ELEMENTS[22240] = Fluid3D([16020,15810,15528,15432],0); -ELEMENTS[22241] = Fluid3D([15810,15528,15432,15002],0); -ELEMENTS[22242] = Fluid3D([16434,16886,16931,16781],0); -ELEMENTS[22243] = Fluid3D([3801,3738,3988,4182],0); -ELEMENTS[22244] = Fluid3D([3738,3988,4182,4125],0); -ELEMENTS[22245] = Fluid3D([3988,3801,4182,4204],0); -ELEMENTS[22246] = Fluid3D([3801,3738,4182,3717],0); -ELEMENTS[22247] = Fluid3D([5138,5733,5622,5853],0); -ELEMENTS[22248] = Fluid3D([8641,8096,8936,7831],0); -ELEMENTS[22249] = Fluid3D([16157,16669,16231,15999],0); -ELEMENTS[22250] = Fluid3D([16231,16157,15999,15780],0); -ELEMENTS[22251] = Fluid3D([16157,15999,15780,15667],0); -ELEMENTS[22252] = Fluid3D([13880,14470,14760,13938],0); -ELEMENTS[22253] = Fluid3D([13880,14470,13938,13515],0); -ELEMENTS[22254] = Fluid3D([14760,13880,13938,14095],0); -ELEMENTS[22255] = Fluid3D([13938,14760,14095,14724],0); -ELEMENTS[22256] = Fluid3D([14095,13938,14724,14009],0); -ELEMENTS[22257] = Fluid3D([14095,13938,14009,13468],0); -ELEMENTS[22258] = Fluid3D([14095,13938,13468,13880],0); -ELEMENTS[22259] = Fluid3D([13938,14724,14009,13927],0); -ELEMENTS[22260] = Fluid3D([14009,13938,13927,13515],0); -ELEMENTS[22261] = Fluid3D([14724,14009,13927,14933],0); -ELEMENTS[22262] = Fluid3D([13938,14724,13927,14470],0); -ELEMENTS[22263] = Fluid3D([14724,13927,14470,14512],0); -ELEMENTS[22264] = Fluid3D([13927,14470,14512,14030],0); -ELEMENTS[22265] = Fluid3D([13927,13938,14470,13515],0); -ELEMENTS[22266] = Fluid3D([14470,13927,13515,14030],0); -ELEMENTS[22267] = Fluid3D([13927,13515,14030,13060],0); -ELEMENTS[22268] = Fluid3D([14470,14724,14512,15163],0); -ELEMENTS[22269] = Fluid3D([13938,14724,14470,14760],0); -ELEMENTS[22270] = Fluid3D([13938,13468,13880,13515],0); -ELEMENTS[22271] = Fluid3D([14724,13927,14512,14933],0); -ELEMENTS[22272] = Fluid3D([14512,14724,14933,15163],0); -ELEMENTS[22273] = Fluid3D([14512,13927,14030,13822],0); -ELEMENTS[22274] = Fluid3D([14933,14512,15163,14742],0); -ELEMENTS[22275] = Fluid3D([14512,15163,14742,14030],0); -ELEMENTS[22276] = Fluid3D([14933,14512,14742,13822],0); -ELEMENTS[22277] = Fluid3D([14512,14470,15163,14030],0); -ELEMENTS[22278] = Fluid3D([14742,14512,14030,13822],0); -ELEMENTS[22279] = Fluid3D([3509,3590,3822,4039],0); -ELEMENTS[22280] = Fluid3D([3590,3822,4039,3844],0); -ELEMENTS[22281] = Fluid3D([3590,3822,3844,3434],0); -ELEMENTS[22282] = Fluid3D([3822,4039,3844,4356],0); -ELEMENTS[22283] = Fluid3D([3822,3844,3434,3984],0); -ELEMENTS[22284] = Fluid3D([3822,3509,4039,4040],0); -ELEMENTS[22285] = Fluid3D([13895,14708,14702,14201],0); -ELEMENTS[22286] = Fluid3D([6292,5910,6691,5958],0); -ELEMENTS[22287] = Fluid3D([6292,5910,5958,5576],0); -ELEMENTS[22288] = Fluid3D([5910,6691,5958,5855],0); -ELEMENTS[22289] = Fluid3D([6691,6292,5958,7076],0); -ELEMENTS[22290] = Fluid3D([5958,6691,7076,6319],0); -ELEMENTS[22291] = Fluid3D([7076,5958,6319,6097],0); -ELEMENTS[22292] = Fluid3D([6691,7076,6319,7220],0); -ELEMENTS[22293] = Fluid3D([6691,7076,7220,6993],0); -ELEMENTS[22294] = Fluid3D([7076,6319,7220,6768],0); -ELEMENTS[22295] = Fluid3D([6319,6691,7220,6660],0); -ELEMENTS[22296] = Fluid3D([6691,7220,6660,7442],0); -ELEMENTS[22297] = Fluid3D([6691,7220,7442,7298],0); -ELEMENTS[22298] = Fluid3D([6691,7220,7298,6993],0); -ELEMENTS[22299] = Fluid3D([7298,6691,6993,6643],0); -ELEMENTS[22300] = Fluid3D([5958,6691,6319,5855],0); -ELEMENTS[22301] = Fluid3D([6319,6691,6660,5855],0); -ELEMENTS[22302] = Fluid3D([6691,7076,6993,6292],0); -ELEMENTS[22303] = Fluid3D([6993,6691,6292,6643],0); -ELEMENTS[22304] = Fluid3D([7076,6993,6292,6111],0); -ELEMENTS[22305] = Fluid3D([6993,6292,6111,6131],0); -ELEMENTS[22306] = Fluid3D([6292,7076,6111,5958],0); -ELEMENTS[22307] = Fluid3D([6111,6292,5958,5576],0); -ELEMENTS[22308] = Fluid3D([7076,6111,5958,6097],0); -ELEMENTS[22309] = Fluid3D([7220,7442,7298,8308],0); -ELEMENTS[22310] = Fluid3D([7220,7442,8308,7498],0); -ELEMENTS[22311] = Fluid3D([7442,8308,7498,7996],0); -ELEMENTS[22312] = Fluid3D([7442,8308,7996,8441],0); -ELEMENTS[22313] = Fluid3D([7442,8308,8441,7298],0); -ELEMENTS[22314] = Fluid3D([7220,6660,7442,7498],0); -ELEMENTS[22315] = Fluid3D([6660,7442,7498,6995],0); -ELEMENTS[22316] = Fluid3D([7498,6660,6995,6446],0); -ELEMENTS[22317] = Fluid3D([7442,7498,6995,7996],0); -ELEMENTS[22318] = Fluid3D([7220,6660,7498,7542],0); -ELEMENTS[22319] = Fluid3D([6660,7498,7542,6937],0); -ELEMENTS[22320] = Fluid3D([6660,7498,6937,6446],0); -ELEMENTS[22321] = Fluid3D([6660,7442,6995,6691],0); -ELEMENTS[22322] = Fluid3D([7498,7542,6937,7664],0); -ELEMENTS[22323] = Fluid3D([6937,7498,7664,7156],0); -ELEMENTS[22324] = Fluid3D([7664,6937,7156,7133],0); -ELEMENTS[22325] = Fluid3D([7442,6691,7298,6643],0); -ELEMENTS[22326] = Fluid3D([7220,6319,6660,6927],0); -ELEMENTS[22327] = Fluid3D([6660,7220,6927,7542],0); -ELEMENTS[22328] = Fluid3D([7220,6927,7542,7456],0); -ELEMENTS[22329] = Fluid3D([6927,7542,7456,7574],0); -ELEMENTS[22330] = Fluid3D([6927,7542,7574,6937],0); -ELEMENTS[22331] = Fluid3D([6927,7542,6937,6660],0); -ELEMENTS[22332] = Fluid3D([6937,6927,6660,6132],0); -ELEMENTS[22333] = Fluid3D([7574,6927,6937,6730],0); -ELEMENTS[22334] = Fluid3D([6927,6937,6730,6132],0); -ELEMENTS[22335] = Fluid3D([7542,7456,7574,8671],0); -ELEMENTS[22336] = Fluid3D([7456,6927,7574,6895],0); -ELEMENTS[22337] = Fluid3D([7456,6927,6895,6768],0); -ELEMENTS[22338] = Fluid3D([7574,6927,6730,6895],0); -ELEMENTS[22339] = Fluid3D([6927,6730,6895,6203],0); -ELEMENTS[22340] = Fluid3D([6730,6895,6203,6158],0); -ELEMENTS[22341] = Fluid3D([6730,6895,6158,7067],0); -ELEMENTS[22342] = Fluid3D([6730,6895,7067,7574],0); -ELEMENTS[22343] = Fluid3D([6927,6730,6203,6132],0); -ELEMENTS[22344] = Fluid3D([6203,6730,6158,5979],0); -ELEMENTS[22345] = Fluid3D([6158,6730,7067,6401],0); -ELEMENTS[22346] = Fluid3D([6203,6730,5979,6132],0); -ELEMENTS[22347] = Fluid3D([6895,6158,7067,6798],0); -ELEMENTS[22348] = Fluid3D([6158,6730,6401,5979],0); -ELEMENTS[22349] = Fluid3D([6895,6158,6798,6120],0); -ELEMENTS[22350] = Fluid3D([6895,6158,6120,6203],0); -ELEMENTS[22351] = Fluid3D([6895,6927,6203,6768],0); -ELEMENTS[22352] = Fluid3D([6730,7067,6401,7273],0); -ELEMENTS[22353] = Fluid3D([6730,7067,7273,7574],0); -ELEMENTS[22354] = Fluid3D([7067,6895,6798,7591],0); -ELEMENTS[22355] = Fluid3D([7067,6895,7591,7574],0); -ELEMENTS[22356] = Fluid3D([7574,7456,6895,7591],0); -ELEMENTS[22357] = Fluid3D([6401,6730,7273,6779],0); -ELEMENTS[22358] = Fluid3D([6895,6798,7591,7190],0); -ELEMENTS[22359] = Fluid3D([6798,6895,6120,7190],0); -ELEMENTS[22360] = Fluid3D([6158,7067,6798,6517],0); -ELEMENTS[22361] = Fluid3D([7067,6798,6517,7342],0); -ELEMENTS[22362] = Fluid3D([7067,6798,7342,7591],0); -ELEMENTS[22363] = Fluid3D([7220,6319,6927,6768],0); -ELEMENTS[22364] = Fluid3D([6798,6517,7342,6767],0); -ELEMENTS[22365] = Fluid3D([7591,6895,7190,7456],0); -ELEMENTS[22366] = Fluid3D([7067,6401,7273,6919],0); -ELEMENTS[22367] = Fluid3D([6401,7273,6919,6779],0); -ELEMENTS[22368] = Fluid3D([7067,6401,6919,6517],0); -ELEMENTS[22369] = Fluid3D([7273,7067,6919,7848],0); -ELEMENTS[22370] = Fluid3D([7273,7067,7848,7574],0); -ELEMENTS[22371] = Fluid3D([7848,7273,7574,7664],0); -ELEMENTS[22372] = Fluid3D([6919,6401,6779,6303],0); -ELEMENTS[22373] = Fluid3D([6919,6401,6303,6374],0); -ELEMENTS[22374] = Fluid3D([6919,6401,6374,6517],0); -ELEMENTS[22375] = Fluid3D([6303,6919,6374,6813],0); -ELEMENTS[22376] = Fluid3D([6919,6374,6813,6980],0); -ELEMENTS[22377] = Fluid3D([6374,6813,6980,6237],0); -ELEMENTS[22378] = Fluid3D([6374,6813,6237,5812],0); -ELEMENTS[22379] = Fluid3D([6813,6980,6237,6803],0); -ELEMENTS[22380] = Fluid3D([6374,6303,6813,5812],0); -ELEMENTS[22381] = Fluid3D([6158,6203,5979,5632],0); -ELEMENTS[22382] = Fluid3D([6158,6798,6120,6027],0); -ELEMENTS[22383] = Fluid3D([6120,6158,6027,5634],0); -ELEMENTS[22384] = Fluid3D([6120,6158,5634,5632],0); -ELEMENTS[22385] = Fluid3D([6158,6798,6027,6517],0); -ELEMENTS[22386] = Fluid3D([6158,6027,5634,5738],0); -ELEMENTS[22387] = Fluid3D([6158,6027,5738,6517],0); -ELEMENTS[22388] = Fluid3D([5634,6158,5738,5979],0); -ELEMENTS[22389] = Fluid3D([6798,7591,7190,7277],0); -ELEMENTS[22390] = Fluid3D([7190,6798,7277,6519],0); -ELEMENTS[22391] = Fluid3D([7190,6798,6519,6120],0); -ELEMENTS[22392] = Fluid3D([7542,7220,7456,7490],0); -ELEMENTS[22393] = Fluid3D([7220,7456,7490,6768],0); -ELEMENTS[22394] = Fluid3D([7490,7220,6768,7076],0); -ELEMENTS[22395] = Fluid3D([7490,7220,7076,8509],0); -ELEMENTS[22396] = Fluid3D([7542,7220,7490,8509],0); -ELEMENTS[22397] = Fluid3D([7067,6158,6401,6517],0); -ELEMENTS[22398] = Fluid3D([6798,6517,6767,6027],0); -ELEMENTS[22399] = Fluid3D([6319,6660,6927,6132],0); -ELEMENTS[22400] = Fluid3D([6798,7277,6519,6767],0); -ELEMENTS[22401] = Fluid3D([6027,6120,5634,5641],0); -ELEMENTS[22402] = Fluid3D([6120,5634,5641,5406],0); -ELEMENTS[22403] = Fluid3D([6027,6120,5641,6519],0); -ELEMENTS[22404] = Fluid3D([5634,6027,5641,5358],0); -ELEMENTS[22405] = Fluid3D([6027,5641,5358,5766],0); -ELEMENTS[22406] = Fluid3D([5641,5358,5766,5165],0); -ELEMENTS[22407] = Fluid3D([5641,5358,5165,4958],0); -ELEMENTS[22408] = Fluid3D([5634,6027,5358,5738],0); -ELEMENTS[22409] = Fluid3D([5641,5634,5358,4958],0); -ELEMENTS[22410] = Fluid3D([6027,5641,5766,6519],0); -ELEMENTS[22411] = Fluid3D([5766,5641,5165,6000],0); -ELEMENTS[22412] = Fluid3D([5766,5641,6000,6519],0); -ELEMENTS[22413] = Fluid3D([5641,5165,6000,5197],0); -ELEMENTS[22414] = Fluid3D([6000,5641,5197,5858],0); -ELEMENTS[22415] = Fluid3D([6000,5641,5858,6120],0); -ELEMENTS[22416] = Fluid3D([5641,5858,6120,5406],0); -ELEMENTS[22417] = Fluid3D([6000,5641,6120,6519],0); -ELEMENTS[22418] = Fluid3D([5641,5165,5197,4958],0); -ELEMENTS[22419] = Fluid3D([5641,5858,5406,5197],0); -ELEMENTS[22420] = Fluid3D([5858,5406,5197,5106],0); -ELEMENTS[22421] = Fluid3D([7342,6798,6767,7277],0); -ELEMENTS[22422] = Fluid3D([5358,6027,5766,5710],0); -ELEMENTS[22423] = Fluid3D([6027,5766,5710,6767],0); -ELEMENTS[22424] = Fluid3D([5766,5358,5710,5173],0); -ELEMENTS[22425] = Fluid3D([5358,6027,5710,5738],0); -ELEMENTS[22426] = Fluid3D([5766,5358,5173,5165],0); -ELEMENTS[22427] = Fluid3D([5358,5710,5173,5385],0); -ELEMENTS[22428] = Fluid3D([5710,5766,5173,5723],0); -ELEMENTS[22429] = Fluid3D([5710,5766,5723,6295],0); -ELEMENTS[22430] = Fluid3D([5723,5710,6295,6010],0); -ELEMENTS[22431] = Fluid3D([5173,5710,5723,5521],0); -ELEMENTS[22432] = Fluid3D([5710,5723,5521,6010],0); -ELEMENTS[22433] = Fluid3D([5723,5521,6010,6049],0); -ELEMENTS[22434] = Fluid3D([5723,5521,6049,5359],0); -ELEMENTS[22435] = Fluid3D([6049,5723,5359,5907],0); -ELEMENTS[22436] = Fluid3D([5723,5521,5359,5173],0); -ELEMENTS[22437] = Fluid3D([6010,5723,6049,6247],0); -ELEMENTS[22438] = Fluid3D([5723,6049,6247,5907],0); -ELEMENTS[22439] = Fluid3D([6049,6010,6247,6475],0); -ELEMENTS[22440] = Fluid3D([6049,6247,5907,6655],0); -ELEMENTS[22441] = Fluid3D([6049,6247,6655,6839],0); -ELEMENTS[22442] = Fluid3D([6049,6247,6839,6475],0); -ELEMENTS[22443] = Fluid3D([6247,6655,6839,7036],0); -ELEMENTS[22444] = Fluid3D([6247,6655,7036,6572],0); -ELEMENTS[22445] = Fluid3D([6839,6247,7036,6767],0); -ELEMENTS[22446] = Fluid3D([5710,5766,6295,6767],0); -ELEMENTS[22447] = Fluid3D([5766,5173,5723,5373],0); -ELEMENTS[22448] = Fluid3D([5766,5173,5373,5165],0); -ELEMENTS[22449] = Fluid3D([5173,5723,5373,5359],0); -ELEMENTS[22450] = Fluid3D([5723,5373,5359,5907],0); -ELEMENTS[22451] = Fluid3D([5723,5766,5373,6247],0); -ELEMENTS[22452] = Fluid3D([5766,5723,6295,6247],0); -ELEMENTS[22453] = Fluid3D([5723,6295,6247,6010],0); -ELEMENTS[22454] = Fluid3D([6295,6247,6010,6475],0); -ELEMENTS[22455] = Fluid3D([6295,5766,6247,6519],0); -ELEMENTS[22456] = Fluid3D([6730,6401,5979,6491],0); -ELEMENTS[22457] = Fluid3D([5979,6730,6491,6132],0); -ELEMENTS[22458] = Fluid3D([6730,6401,6491,6779],0); -ELEMENTS[22459] = Fluid3D([6401,6491,6779,6060],0); -ELEMENTS[22460] = Fluid3D([6491,6779,6060,6002],0); -ELEMENTS[22461] = Fluid3D([6401,6491,6060,5979],0); -ELEMENTS[22462] = Fluid3D([6517,7067,7342,7169],0); -ELEMENTS[22463] = Fluid3D([7067,7342,7169,7808],0); -ELEMENTS[22464] = Fluid3D([7067,7342,7808,7591],0); -ELEMENTS[22465] = Fluid3D([7342,7169,7808,7978],0); -ELEMENTS[22466] = Fluid3D([7808,7342,7978,7804],0); -ELEMENTS[22467] = Fluid3D([7342,7978,7804,7252],0); -ELEMENTS[22468] = Fluid3D([7804,7342,7252,6767],0); -ELEMENTS[22469] = Fluid3D([7342,7252,6767,6841],0); -ELEMENTS[22470] = Fluid3D([7252,6767,6841,6839],0); -ELEMENTS[22471] = Fluid3D([7169,7067,7808,6919],0); -ELEMENTS[22472] = Fluid3D([7342,7978,7252,6841],0); -ELEMENTS[22473] = Fluid3D([7169,7067,6919,6517],0); -ELEMENTS[22474] = Fluid3D([7342,7808,7591,7804],0); -ELEMENTS[22475] = Fluid3D([7342,6517,7169,6841],0); -ELEMENTS[22476] = Fluid3D([7808,7067,7591,7848],0); -ELEMENTS[22477] = Fluid3D([6798,7591,7277,7342],0); -ELEMENTS[22478] = Fluid3D([7277,7190,6519,7078],0); -ELEMENTS[22479] = Fluid3D([6517,7342,6767,6841],0); -ELEMENTS[22480] = Fluid3D([5710,6295,6010,6363],0); -ELEMENTS[22481] = Fluid3D([6010,5710,6363,5385],0); -ELEMENTS[22482] = Fluid3D([6295,6010,6363,6475],0); -ELEMENTS[22483] = Fluid3D([6798,6120,6027,6519],0); -ELEMENTS[22484] = Fluid3D([7591,7190,7277,8311],0); -ELEMENTS[22485] = Fluid3D([12787,12231,13142,13049],0); -ELEMENTS[22486] = Fluid3D([16485,16355,16767,16805],0); -ELEMENTS[22487] = Fluid3D([11530,10895,11212,10544],0); -ELEMENTS[22488] = Fluid3D([11530,10895,10544,10964],0); -ELEMENTS[22489] = Fluid3D([10895,11212,10544,10056],0); -ELEMENTS[22490] = Fluid3D([11212,10544,10056,10861],0); -ELEMENTS[22491] = Fluid3D([10544,10056,10861,9658],0); -ELEMENTS[22492] = Fluid3D([10056,10861,9658,10288],0); -ELEMENTS[22493] = Fluid3D([11212,11530,10544,11317],0); -ELEMENTS[22494] = Fluid3D([11530,10544,11317,11087],0); -ELEMENTS[22495] = Fluid3D([11530,10544,11087,10964],0); -ELEMENTS[22496] = Fluid3D([11317,11530,11087,12038],0); -ELEMENTS[22497] = Fluid3D([11530,11087,12038,11777],0); -ELEMENTS[22498] = Fluid3D([11317,11530,12038,12182],0); -ELEMENTS[22499] = Fluid3D([11530,12038,12182,12664],0); -ELEMENTS[22500] = Fluid3D([11317,11530,12182,11212],0); -ELEMENTS[22501] = Fluid3D([10544,10056,9658,9802],0); -ELEMENTS[22502] = Fluid3D([10544,10056,9802,10895],0); -ELEMENTS[22503] = Fluid3D([10056,9658,9802,9164],0); -ELEMENTS[22504] = Fluid3D([10056,9658,9164,9675],0); -ELEMENTS[22505] = Fluid3D([10056,9658,9675,10288],0); -ELEMENTS[22506] = Fluid3D([9675,10056,10288,9936],0); -ELEMENTS[22507] = Fluid3D([10288,9675,9936,9444],0); -ELEMENTS[22508] = Fluid3D([10288,9675,9444,9267],0); -ELEMENTS[22509] = Fluid3D([10288,9675,9267,9869],0); -ELEMENTS[22510] = Fluid3D([9675,9267,9869,9658],0); -ELEMENTS[22511] = Fluid3D([10288,9675,9869,9658],0); -ELEMENTS[22512] = Fluid3D([9675,9444,9267,8653],0); -ELEMENTS[22513] = Fluid3D([9267,9675,8653,8775],0); -ELEMENTS[22514] = Fluid3D([9267,9675,8775,9658],0); -ELEMENTS[22515] = Fluid3D([8653,9267,8775,8410],0); -ELEMENTS[22516] = Fluid3D([8653,9267,8410,9084],0); -ELEMENTS[22517] = Fluid3D([9267,8775,8410,8838],0); -ELEMENTS[22518] = Fluid3D([9267,8775,8838,9658],0); -ELEMENTS[22519] = Fluid3D([9267,9869,9658,9426],0); -ELEMENTS[22520] = Fluid3D([9869,9658,9426,10287],0); -ELEMENTS[22521] = Fluid3D([9869,9658,10287,10861],0); -ELEMENTS[22522] = Fluid3D([9869,9658,10861,10288],0); -ELEMENTS[22523] = Fluid3D([10861,9869,10288,9906],0); -ELEMENTS[22524] = Fluid3D([10287,9869,10861,10464],0); -ELEMENTS[22525] = Fluid3D([9869,10861,10464,9906],0); -ELEMENTS[22526] = Fluid3D([9426,9869,10287,10464],0); -ELEMENTS[22527] = Fluid3D([9675,8653,8775,9164],0); -ELEMENTS[22528] = Fluid3D([8775,9675,9164,9658],0); -ELEMENTS[22529] = Fluid3D([9164,8775,9658,8798],0); -ELEMENTS[22530] = Fluid3D([9164,8775,8798,8386],0); -ELEMENTS[22531] = Fluid3D([9164,8775,8386,8653],0); -ELEMENTS[22532] = Fluid3D([9267,9869,9426,9906],0); -ELEMENTS[22533] = Fluid3D([8410,9267,8838,9276],0); -ELEMENTS[22534] = Fluid3D([9267,8838,9276,9426],0); -ELEMENTS[22535] = Fluid3D([8838,9276,9426,9019],0); -ELEMENTS[22536] = Fluid3D([9426,8838,9019,8866],0); -ELEMENTS[22537] = Fluid3D([9426,8838,8866,9658],0); -ELEMENTS[22538] = Fluid3D([9276,9426,9019,9813],0); -ELEMENTS[22539] = Fluid3D([9267,8838,9426,9658],0); -ELEMENTS[22540] = Fluid3D([9276,9426,9813,10464],0); -ELEMENTS[22541] = Fluid3D([8838,9276,9019,8405],0); -ELEMENTS[22542] = Fluid3D([8838,9276,8405,8410],0); -ELEMENTS[22543] = Fluid3D([9276,9267,9426,9906],0); -ELEMENTS[22544] = Fluid3D([9019,9426,8866,9813],0); -ELEMENTS[22545] = Fluid3D([8838,9019,8866,8114],0); -ELEMENTS[22546] = Fluid3D([9019,8838,8405,8114],0); -ELEMENTS[22547] = Fluid3D([8866,8838,8114,8366],0); -ELEMENTS[22548] = Fluid3D([8866,8838,8366,9658],0); -ELEMENTS[22549] = Fluid3D([9426,9813,10464,10287],0); -ELEMENTS[22550] = Fluid3D([9813,9276,10464,10524],0); -ELEMENTS[22551] = Fluid3D([9019,9276,9813,9312],0); -ELEMENTS[22552] = Fluid3D([9276,9019,8405,9312],0); -ELEMENTS[22553] = Fluid3D([8405,8838,8410,8114],0); -ELEMENTS[22554] = Fluid3D([9276,9813,9312,10524],0); -ELEMENTS[22555] = Fluid3D([9813,10464,10287,10813],0); -ELEMENTS[22556] = Fluid3D([9813,10464,10813,10363],0); -ELEMENTS[22557] = Fluid3D([8838,8114,8366,8410],0); -ELEMENTS[22558] = Fluid3D([10813,9813,10363,9966],0); -ELEMENTS[22559] = Fluid3D([9813,10363,9966,9258],0); -ELEMENTS[22560] = Fluid3D([9813,10363,9258,9312],0); -ELEMENTS[22561] = Fluid3D([9258,9813,9312,9019],0); -ELEMENTS[22562] = Fluid3D([9312,9258,9019,8596],0); -ELEMENTS[22563] = Fluid3D([9312,9258,8596,9205],0); -ELEMENTS[22564] = Fluid3D([9312,9258,9205,10363],0); -ELEMENTS[22565] = Fluid3D([9258,9019,8596,8631],0); -ELEMENTS[22566] = Fluid3D([9258,9813,9019,9966],0); -ELEMENTS[22567] = Fluid3D([9258,8596,9205,8861],0); -ELEMENTS[22568] = Fluid3D([8596,9312,9205,8618],0); -ELEMENTS[22569] = Fluid3D([9813,10363,9312,10524],0); -ELEMENTS[22570] = Fluid3D([9312,9205,8618,10049],0); -ELEMENTS[22571] = Fluid3D([9267,10288,9869,9906],0); -ELEMENTS[22572] = Fluid3D([9276,9426,10464,9906],0); -ELEMENTS[22573] = Fluid3D([8596,9312,8618,8405],0); -ELEMENTS[22574] = Fluid3D([8775,8798,8386,8366],0); -ELEMENTS[22575] = Fluid3D([8775,8798,8366,9658],0); -ELEMENTS[22576] = Fluid3D([8798,9164,8386,8767],0); -ELEMENTS[22577] = Fluid3D([9164,8386,8767,8885],0); -ELEMENTS[22578] = Fluid3D([9426,9869,10464,9906],0); -ELEMENTS[22579] = Fluid3D([9019,9312,8596,8405],0); -ELEMENTS[22580] = Fluid3D([9164,8386,8885,8477],0); -ELEMENTS[22581] = Fluid3D([9164,8386,8477,8653],0); -ELEMENTS[22582] = Fluid3D([8798,9164,8767,9802],0); -ELEMENTS[22583] = Fluid3D([9813,10464,10363,10524],0); -ELEMENTS[22584] = Fluid3D([10813,9813,9966,10287],0); -ELEMENTS[22585] = Fluid3D([8767,9164,8885,9735],0); -ELEMENTS[22586] = Fluid3D([9444,9267,8653,9084],0); -ELEMENTS[22587] = Fluid3D([8405,9019,8114,8596],0); -ELEMENTS[22588] = Fluid3D([8798,8386,8366,7974],0); -ELEMENTS[22589] = Fluid3D([8366,8798,7974,8474],0); -ELEMENTS[22590] = Fluid3D([8366,8798,8474,8866],0); -ELEMENTS[22591] = Fluid3D([8798,7974,8474,8651],0); -ELEMENTS[22592] = Fluid3D([8798,7974,8651,8767],0); -ELEMENTS[22593] = Fluid3D([8474,8798,8651,9375],0); -ELEMENTS[22594] = Fluid3D([8474,8798,9375,8866],0); -ELEMENTS[22595] = Fluid3D([8474,8366,8866,8114],0); -ELEMENTS[22596] = Fluid3D([8798,8651,9375,9802],0); -ELEMENTS[22597] = Fluid3D([7974,8366,8474,7669],0); -ELEMENTS[22598] = Fluid3D([8366,8474,7669,8114],0); -ELEMENTS[22599] = Fluid3D([9658,9426,10287,8866],0); -ELEMENTS[22600] = Fluid3D([8767,9164,9735,9802],0); -ELEMENTS[22601] = Fluid3D([8775,8410,8838,8366],0); -ELEMENTS[22602] = Fluid3D([8838,8775,8366,9658],0); -ELEMENTS[22603] = Fluid3D([8885,9164,8477,9936],0); -ELEMENTS[22604] = Fluid3D([9019,8866,8114,8324],0); -ELEMENTS[22605] = Fluid3D([8114,9019,8324,8596],0); -ELEMENTS[22606] = Fluid3D([8866,8114,8324,8034],0); -ELEMENTS[22607] = Fluid3D([10363,9966,9258,10018],0); -ELEMENTS[22608] = Fluid3D([9675,10056,9936,9164],0); -ELEMENTS[22609] = Fluid3D([8386,8767,8885,7678],0); -ELEMENTS[22610] = Fluid3D([8114,8324,8034,7773],0); -ELEMENTS[22611] = Fluid3D([9658,9164,8798,9802],0); -ELEMENTS[22612] = Fluid3D([7974,8474,8651,7881],0); -ELEMENTS[22613] = Fluid3D([8651,7974,7881,7537],0); -ELEMENTS[22614] = Fluid3D([8474,8651,7881,8728],0); -ELEMENTS[22615] = Fluid3D([8651,7881,8728,8376],0); -ELEMENTS[22616] = Fluid3D([8651,7881,8376,7537],0); -ELEMENTS[22617] = Fluid3D([8474,8651,8728,9375],0); -ELEMENTS[22618] = Fluid3D([8728,8651,8376,9299],0); -ELEMENTS[22619] = Fluid3D([8728,8651,9299,9375],0); -ELEMENTS[22620] = Fluid3D([9164,8885,9735,9936],0); -ELEMENTS[22621] = Fluid3D([8386,8775,8366,7558],0); -ELEMENTS[22622] = Fluid3D([9019,8866,8324,9447],0); -ELEMENTS[22623] = Fluid3D([9019,8866,9447,9813],0); -ELEMENTS[22624] = Fluid3D([8324,9019,9447,8631],0); -ELEMENTS[22625] = Fluid3D([8866,8324,9447,8442],0); -ELEMENTS[22626] = Fluid3D([9658,10287,10861,10544],0); -ELEMENTS[22627] = Fluid3D([9658,10287,10544,9375],0); -ELEMENTS[22628] = Fluid3D([8386,8885,8477,7821],0); -ELEMENTS[22629] = Fluid3D([8775,8653,8410,7558],0); -ELEMENTS[22630] = Fluid3D([8324,8866,8034,8442],0); -ELEMENTS[22631] = Fluid3D([9205,8596,8618,8312],0); -ELEMENTS[22632] = Fluid3D([8618,9205,8312,9038],0); -ELEMENTS[22633] = Fluid3D([9205,8312,9038,8963],0); -ELEMENTS[22634] = Fluid3D([9205,8596,8312,8861],0); -ELEMENTS[22635] = Fluid3D([9205,8312,8963,8861],0); -ELEMENTS[22636] = Fluid3D([8618,9205,9038,10049],0); -ELEMENTS[22637] = Fluid3D([8596,8618,8312,7502],0); -ELEMENTS[22638] = Fluid3D([9038,9205,8963,9819],0); -ELEMENTS[22639] = Fluid3D([9038,9205,9819,10049],0); -ELEMENTS[22640] = Fluid3D([8312,8618,9038,8337],0); -ELEMENTS[22641] = Fluid3D([8312,8618,8337,7502],0); -ELEMENTS[22642] = Fluid3D([8618,9038,8337,9165],0); -ELEMENTS[22643] = Fluid3D([8618,9038,9165,10049],0); -ELEMENTS[22644] = Fluid3D([8337,8618,9165,8153],0); -ELEMENTS[22645] = Fluid3D([8337,8618,8153,7502],0); -ELEMENTS[22646] = Fluid3D([8153,8337,7502,7936],0); -ELEMENTS[22647] = Fluid3D([8153,8337,7936,9393],0); -ELEMENTS[22648] = Fluid3D([8866,8114,8034,8474],0); -ELEMENTS[22649] = Fluid3D([8034,8866,8474,8755],0); -ELEMENTS[22650] = Fluid3D([8474,8034,8755,8266],0); -ELEMENTS[22651] = Fluid3D([8034,8755,8266,8442],0); -ELEMENTS[22652] = Fluid3D([8755,8266,8442,9133],0); -ELEMENTS[22653] = Fluid3D([8755,8266,9133,8982],0); -ELEMENTS[22654] = Fluid3D([8442,8755,9133,9447],0); -ELEMENTS[22655] = Fluid3D([8755,8474,8266,8728],0); -ELEMENTS[22656] = Fluid3D([8866,8474,8755,9375],0); -ELEMENTS[22657] = Fluid3D([8034,8866,8755,8442],0); -ELEMENTS[22658] = Fluid3D([10861,10287,10464,11317],0); -ELEMENTS[22659] = Fluid3D([8386,8798,8767,7974],0); -ELEMENTS[22660] = Fluid3D([8885,8767,9735,9087],0); -ELEMENTS[22661] = Fluid3D([8767,9735,9087,9614],0); -ELEMENTS[22662] = Fluid3D([8767,9735,9614,9802],0); -ELEMENTS[22663] = Fluid3D([7974,8366,7669,7222],0); -ELEMENTS[22664] = Fluid3D([9735,8885,9087,9573],0); -ELEMENTS[22665] = Fluid3D([9735,8885,9573,9588],0); -ELEMENTS[22666] = Fluid3D([9735,8885,9588,9936],0); -ELEMENTS[22667] = Fluid3D([9658,10544,9802,9375],0); -ELEMENTS[22668] = Fluid3D([9267,8410,9084,9276],0); -ELEMENTS[22669] = Fluid3D([9087,9735,9573,10061],0); -ELEMENTS[22670] = Fluid3D([9087,9735,10061,9614],0); -ELEMENTS[22671] = Fluid3D([9735,9573,10061,10488],0); -ELEMENTS[22672] = Fluid3D([9735,9573,10488,9588],0); -ELEMENTS[22673] = Fluid3D([9573,9087,10061,8863],0); -ELEMENTS[22674] = Fluid3D([9573,9087,8863,8885],0); -ELEMENTS[22675] = Fluid3D([9573,10061,10488,10386],0); -ELEMENTS[22676] = Fluid3D([10488,9573,10386,10186],0); -ELEMENTS[22677] = Fluid3D([10488,9573,10186,9588],0); -ELEMENTS[22678] = Fluid3D([10061,10488,10386,11083],0); -ELEMENTS[22679] = Fluid3D([9573,10061,10386,9659],0); -ELEMENTS[22680] = Fluid3D([10061,10488,11083,11422],0); -ELEMENTS[22681] = Fluid3D([10488,10386,11083,11285],0); -ELEMENTS[22682] = Fluid3D([8885,8767,9087,8265],0); -ELEMENTS[22683] = Fluid3D([8767,9087,8265,8370],0); -ELEMENTS[22684] = Fluid3D([8767,9087,8370,9614],0); -ELEMENTS[22685] = Fluid3D([8885,8767,8265,7678],0); -ELEMENTS[22686] = Fluid3D([9087,8885,8265,8863],0); -ELEMENTS[22687] = Fluid3D([8376,8728,9299,8835],0); -ELEMENTS[22688] = Fluid3D([9087,8265,8370,8360],0); -ELEMENTS[22689] = Fluid3D([8370,9087,8360,9157],0); -ELEMENTS[22690] = Fluid3D([9087,8265,8360,8863],0); -ELEMENTS[22691] = Fluid3D([8360,9087,8863,9157],0); -ELEMENTS[22692] = Fluid3D([8265,8370,8360,7427],0); -ELEMENTS[22693] = Fluid3D([8370,9087,9157,9614],0); -ELEMENTS[22694] = Fluid3D([8360,8370,9157,8160],0); -ELEMENTS[22695] = Fluid3D([8370,9157,8160,9028],0); -ELEMENTS[22696] = Fluid3D([8360,8370,8160,7427],0); -ELEMENTS[22697] = Fluid3D([9157,8160,9028,9150],0); -ELEMENTS[22698] = Fluid3D([9157,8160,9150,8687],0); -ELEMENTS[22699] = Fluid3D([9157,8360,8160,8687],0); -ELEMENTS[22700] = Fluid3D([8160,9028,9150,8431],0); -ELEMENTS[22701] = Fluid3D([8160,9150,8687,8336],0); -ELEMENTS[22702] = Fluid3D([9150,8160,8431,8336],0); -ELEMENTS[22703] = Fluid3D([9028,9150,8431,9418],0); -ELEMENTS[22704] = Fluid3D([9028,9150,9418,9918],0); -ELEMENTS[22705] = Fluid3D([9150,8431,9418,8814],0); -ELEMENTS[22706] = Fluid3D([8431,9028,9418,8867],0); -ELEMENTS[22707] = Fluid3D([9150,8431,8814,8336],0); -ELEMENTS[22708] = Fluid3D([8431,9028,8867,8137],0); -ELEMENTS[22709] = Fluid3D([8431,9028,8137,8160],0); -ELEMENTS[22710] = Fluid3D([9028,8867,8137,8902],0); -ELEMENTS[22711] = Fluid3D([9028,8867,8902,9724],0); -ELEMENTS[22712] = Fluid3D([9028,8867,9724,9418],0); -ELEMENTS[22713] = Fluid3D([8867,8137,8902,8376],0); -ELEMENTS[22714] = Fluid3D([8137,8902,8376,8651],0); -ELEMENTS[22715] = Fluid3D([8902,8376,8651,9299],0); -ELEMENTS[22716] = Fluid3D([8902,8376,9299,9042],0); -ELEMENTS[22717] = Fluid3D([9299,8902,9042,9724],0); -ELEMENTS[22718] = Fluid3D([8902,8376,9042,8867],0); -ELEMENTS[22719] = Fluid3D([8651,8902,9299,9445],0); -ELEMENTS[22720] = Fluid3D([8902,9299,9445,9724],0); -ELEMENTS[22721] = Fluid3D([9042,8902,8867,9724],0); -ELEMENTS[22722] = Fluid3D([8867,9042,9724,9612],0); -ELEMENTS[22723] = Fluid3D([8867,9042,9612,8729],0); -ELEMENTS[22724] = Fluid3D([8651,8902,9445,8370],0); -ELEMENTS[22725] = Fluid3D([8376,9299,9042,8835],0); -ELEMENTS[22726] = Fluid3D([9299,8651,9445,9375],0); -ELEMENTS[22727] = Fluid3D([9724,8867,9612,9418],0); -ELEMENTS[22728] = Fluid3D([9028,9150,9918,9157],0); -ELEMENTS[22729] = Fluid3D([8137,9028,8902,8370],0); -ELEMENTS[22730] = Fluid3D([8370,9157,9028,9614],0); -ELEMENTS[22731] = Fluid3D([9150,9418,9918,9940],0); -ELEMENTS[22732] = Fluid3D([9150,9418,9940,8814],0); -ELEMENTS[22733] = Fluid3D([9918,9150,9940,10351],0); -ELEMENTS[22734] = Fluid3D([9418,9918,9940,10453],0); -ELEMENTS[22735] = Fluid3D([9940,9418,10453,9954],0); -ELEMENTS[22736] = Fluid3D([9418,10453,9954,9612],0); -ELEMENTS[22737] = Fluid3D([9418,9918,10453,9724],0); -ELEMENTS[22738] = Fluid3D([9940,9418,9954,8814],0); -ELEMENTS[22739] = Fluid3D([9918,9940,10453,10796],0); -ELEMENTS[22740] = Fluid3D([9918,9940,10796,10351],0); -ELEMENTS[22741] = Fluid3D([9940,10453,10796,10893],0); -ELEMENTS[22742] = Fluid3D([9940,10453,10893,9954],0); -ELEMENTS[22743] = Fluid3D([10796,9940,10893,10199],0); -ELEMENTS[22744] = Fluid3D([10453,9918,10796,10858],0); -ELEMENTS[22745] = Fluid3D([9918,10796,10858,10591],0); -ELEMENTS[22746] = Fluid3D([10453,9918,10858,9724],0); -ELEMENTS[22747] = Fluid3D([10796,10453,10858,11477],0); -ELEMENTS[22748] = Fluid3D([10796,10453,11477,10893],0); -ELEMENTS[22749] = Fluid3D([10453,10858,11477,11063],0); -ELEMENTS[22750] = Fluid3D([10858,11477,11063,11785],0); -ELEMENTS[22751] = Fluid3D([10858,11477,11785,11682],0); -ELEMENTS[22752] = Fluid3D([10858,11477,11682,10796],0); -ELEMENTS[22753] = Fluid3D([10453,10858,11063,9724],0); -ELEMENTS[22754] = Fluid3D([9918,10796,10591,10351],0); -ELEMENTS[22755] = Fluid3D([11477,10453,11063,11152],0); -ELEMENTS[22756] = Fluid3D([11477,10453,11152,10893],0); -ELEMENTS[22757] = Fluid3D([10453,11063,11152,10439],0); -ELEMENTS[22758] = Fluid3D([10453,11063,10439,9612],0); -ELEMENTS[22759] = Fluid3D([11152,10453,10439,9954],0); -ELEMENTS[22760] = Fluid3D([11063,11477,11152,11990],0); -ELEMENTS[22761] = Fluid3D([11063,11477,11990,11785],0); -ELEMENTS[22762] = Fluid3D([11477,11152,11990,11993],0); -ELEMENTS[22763] = Fluid3D([11152,11063,11990,11291],0); -ELEMENTS[22764] = Fluid3D([11152,11063,11291,10439],0); -ELEMENTS[22765] = Fluid3D([11152,11990,11993,12143],0); -ELEMENTS[22766] = Fluid3D([11477,11152,11993,10893],0); -ELEMENTS[22767] = Fluid3D([11063,11990,11291,11784],0); -ELEMENTS[22768] = Fluid3D([11063,11990,11784,11785],0); -ELEMENTS[22769] = Fluid3D([11990,11291,11784,12225],0); -ELEMENTS[22770] = Fluid3D([11990,11291,12225,12143],0); -ELEMENTS[22771] = Fluid3D([11291,11063,11784,10805],0); -ELEMENTS[22772] = Fluid3D([11291,11063,10805,10439],0); -ELEMENTS[22773] = Fluid3D([11063,11784,10805,11215],0); -ELEMENTS[22774] = Fluid3D([11063,11784,11215,11785],0); -ELEMENTS[22775] = Fluid3D([10805,11063,11215,9724],0); -ELEMENTS[22776] = Fluid3D([11784,11291,10805,11826],0); -ELEMENTS[22777] = Fluid3D([11784,10805,11215,11402],0); -ELEMENTS[22778] = Fluid3D([11784,10805,11402,11826],0); -ELEMENTS[22779] = Fluid3D([10805,11215,11402,10408],0); -ELEMENTS[22780] = Fluid3D([10805,11215,10408,9724],0); -ELEMENTS[22781] = Fluid3D([11402,10805,10408,10669],0); -ELEMENTS[22782] = Fluid3D([11402,10805,10669,11826],0); -ELEMENTS[22783] = Fluid3D([10805,10408,10669,9836],0); -ELEMENTS[22784] = Fluid3D([10805,10408,9836,9724],0); -ELEMENTS[22785] = Fluid3D([10408,10669,9836,9720],0); -ELEMENTS[22786] = Fluid3D([11215,11784,11402,11941],0); -ELEMENTS[22787] = Fluid3D([11215,11784,11941,11785],0); -ELEMENTS[22788] = Fluid3D([11784,11402,11941,12329],0); -ELEMENTS[22789] = Fluid3D([11402,11215,11941,11261],0); -ELEMENTS[22790] = Fluid3D([11215,11941,11261,11777],0); -ELEMENTS[22791] = Fluid3D([11941,11261,11777,12120],0); -ELEMENTS[22792] = Fluid3D([11261,11777,12120,11087],0); -ELEMENTS[22793] = Fluid3D([11777,11941,12120,12964],0); -ELEMENTS[22794] = Fluid3D([11941,11261,12120,11402],0); -ELEMENTS[22795] = Fluid3D([11402,11215,11261,10408],0); -ELEMENTS[22796] = Fluid3D([10408,11402,10669,10795],0); -ELEMENTS[22797] = Fluid3D([10408,11402,10795,11261],0); -ELEMENTS[22798] = Fluid3D([11402,10669,10795,11960],0); -ELEMENTS[22799] = Fluid3D([10669,10408,10795,9720],0); -ELEMENTS[22800] = Fluid3D([10796,10858,10591,11682],0); -ELEMENTS[22801] = Fluid3D([11785,10858,11682,11735],0); -ELEMENTS[22802] = Fluid3D([7974,8474,7881,7669],0); -ELEMENTS[22803] = Fluid3D([9573,10386,10186,9659],0); -ELEMENTS[22804] = Fluid3D([8160,8370,9028,8137],0); -ELEMENTS[22805] = Fluid3D([8902,9028,9724,9445],0); -ELEMENTS[22806] = Fluid3D([7881,8728,8376,8128],0); -ELEMENTS[22807] = Fluid3D([7881,8728,8128,8266],0); -ELEMENTS[22808] = Fluid3D([8728,8376,8128,8835],0); -ELEMENTS[22809] = Fluid3D([9150,8687,8336,9566],0); -ELEMENTS[22810] = Fluid3D([11212,10544,10861,11317],0); -ELEMENTS[22811] = Fluid3D([8867,8431,8137,7923],0); -ELEMENTS[22812] = Fluid3D([8431,8137,7923,7233],0); -ELEMENTS[22813] = Fluid3D([8137,7923,7233,8015],0); -ELEMENTS[22814] = Fluid3D([8867,8431,7923,8720],0); -ELEMENTS[22815] = Fluid3D([8867,8431,8720,9418],0); -ELEMENTS[22816] = Fluid3D([7923,8867,8720,8729],0); -ELEMENTS[22817] = Fluid3D([8431,7923,8720,7938],0); -ELEMENTS[22818] = Fluid3D([8431,7923,7938,7599],0); -ELEMENTS[22819] = Fluid3D([8720,8431,7938,8814],0); -ELEMENTS[22820] = Fluid3D([7938,8431,7599,8336],0); -ELEMENTS[22821] = Fluid3D([7923,8720,7938,7823],0); -ELEMENTS[22822] = Fluid3D([8431,7923,7599,7233],0); -ELEMENTS[22823] = Fluid3D([7923,7599,7233,7130],0); -ELEMENTS[22824] = Fluid3D([8137,8867,7923,8015],0); -ELEMENTS[22825] = Fluid3D([7923,7938,7599,7130],0); -ELEMENTS[22826] = Fluid3D([11063,10858,11785,11215],0); -ELEMENTS[22827] = Fluid3D([12038,11317,12182,12163],0); -ELEMENTS[22828] = Fluid3D([12182,12038,12163,12911],0); -ELEMENTS[22829] = Fluid3D([12038,12163,12911,12565],0); -ELEMENTS[22830] = Fluid3D([12911,12038,12565,13106],0); -ELEMENTS[22831] = Fluid3D([12038,12163,12565,11373],0); -ELEMENTS[22832] = Fluid3D([12163,12565,11373,12200],0); -ELEMENTS[22833] = Fluid3D([12163,12565,12200,13012],0); -ELEMENTS[22834] = Fluid3D([12565,12200,13012,13290],0); -ELEMENTS[22835] = Fluid3D([13012,12565,13290,13620],0); -ELEMENTS[22836] = Fluid3D([12038,11317,12163,11373],0); -ELEMENTS[22837] = Fluid3D([12163,12565,13012,12911],0); -ELEMENTS[22838] = Fluid3D([12182,12038,12911,12664],0); -ELEMENTS[22839] = Fluid3D([12565,11373,12200,12083],0); -ELEMENTS[22840] = Fluid3D([12565,11373,12083,11976],0); -ELEMENTS[22841] = Fluid3D([11373,12083,11976,11325],0); -ELEMENTS[22842] = Fluid3D([12083,11976,11325,11842],0); -ELEMENTS[22843] = Fluid3D([12083,11976,11842,12774],0); -ELEMENTS[22844] = Fluid3D([11842,12083,12774,12452],0); -ELEMENTS[22845] = Fluid3D([11373,12200,12083,11316],0); -ELEMENTS[22846] = Fluid3D([12200,12083,11316,12165],0); -ELEMENTS[22847] = Fluid3D([12200,12083,12165,12968],0); -ELEMENTS[22848] = Fluid3D([11373,12200,11316,11197],0); -ELEMENTS[22849] = Fluid3D([12083,11373,11316,11325],0); -ELEMENTS[22850] = Fluid3D([12200,12565,12083,13290],0); -ELEMENTS[22851] = Fluid3D([12565,11373,11976,12038],0); -ELEMENTS[22852] = Fluid3D([11976,11325,11842,11294],0); -ELEMENTS[22853] = Fluid3D([11842,11976,11294,12602],0); -ELEMENTS[22854] = Fluid3D([11325,11842,11294,10988],0); -ELEMENTS[22855] = Fluid3D([11976,11325,11294,11087],0); -ELEMENTS[22856] = Fluid3D([11317,12182,12163,11764],0); -ELEMENTS[22857] = Fluid3D([12182,12163,11764,12740],0); -ELEMENTS[22858] = Fluid3D([12163,11764,12740,12283],0); -ELEMENTS[22859] = Fluid3D([11764,12740,12283,12267],0); -ELEMENTS[22860] = Fluid3D([11764,12740,12267,12320],0); -ELEMENTS[22861] = Fluid3D([11764,12740,12320,12182],0); -ELEMENTS[22862] = Fluid3D([11317,12182,11764,11212],0); -ELEMENTS[22863] = Fluid3D([12740,12283,12267,13127],0); -ELEMENTS[22864] = Fluid3D([12283,12267,13127,12477],0); -ELEMENTS[22865] = Fluid3D([12267,12740,13127,13279],0); -ELEMENTS[22866] = Fluid3D([12740,12283,13127,13012],0); -ELEMENTS[22867] = Fluid3D([12283,12267,12477,11747],0); -ELEMENTS[22868] = Fluid3D([12283,12267,11747,11764],0); -ELEMENTS[22869] = Fluid3D([12477,12283,11747,11519],0); -ELEMENTS[22870] = Fluid3D([11747,12477,11519,11622],0); -ELEMENTS[22871] = Fluid3D([11519,11747,11622,10681],0); -ELEMENTS[22872] = Fluid3D([12283,11747,11519,11241],0); -ELEMENTS[22873] = Fluid3D([11747,11519,11241,10524],0); -ELEMENTS[22874] = Fluid3D([11747,12477,11622,11613],0); -ELEMENTS[22875] = Fluid3D([12283,11747,11241,11764],0); -ELEMENTS[22876] = Fluid3D([11747,11519,10524,10681],0); -ELEMENTS[22877] = Fluid3D([12267,12477,11747,11613],0); -ELEMENTS[22878] = Fluid3D([12163,11764,12283,11241],0); -ELEMENTS[22879] = Fluid3D([12163,11317,11764,11241],0); -ELEMENTS[22880] = Fluid3D([12267,13127,12477,12949],0); -ELEMENTS[22881] = Fluid3D([13127,12477,12949,13383],0); -ELEMENTS[22882] = Fluid3D([12267,13127,12949,13279],0); -ELEMENTS[22883] = Fluid3D([12477,12267,12949,11613],0); -ELEMENTS[22884] = Fluid3D([12477,12949,13383,12816],0); -ELEMENTS[22885] = Fluid3D([12477,12949,12816,11613],0); -ELEMENTS[22886] = Fluid3D([12949,13383,12816,13851],0); -ELEMENTS[22887] = Fluid3D([12949,13127,13383,13866],0); -ELEMENTS[22888] = Fluid3D([12949,13127,13866,13279],0); -ELEMENTS[22889] = Fluid3D([13127,13383,13866,14295],0); -ELEMENTS[22890] = Fluid3D([13383,12949,13866,13851],0); -ELEMENTS[22891] = Fluid3D([13127,12477,13383,12764],0); -ELEMENTS[22892] = Fluid3D([13383,13127,12764,14295],0); -ELEMENTS[22893] = Fluid3D([13127,12477,12764,12283],0); -ELEMENTS[22894] = Fluid3D([12477,13383,12764,12609],0); -ELEMENTS[22895] = Fluid3D([12764,12477,12609,11519],0); -ELEMENTS[22896] = Fluid3D([12477,13383,12609,12816],0); -ELEMENTS[22897] = Fluid3D([13383,12764,12609,13602],0); -ELEMENTS[22898] = Fluid3D([13383,12764,13602,14295],0); -ELEMENTS[22899] = Fluid3D([12764,12609,13602,12851],0); -ELEMENTS[22900] = Fluid3D([13602,12764,12851,13977],0); -ELEMENTS[22901] = Fluid3D([12764,12609,12851,12205],0); -ELEMENTS[22902] = Fluid3D([12609,12851,12205,11708],0); -ELEMENTS[22903] = Fluid3D([12764,12609,12205,11519],0); -ELEMENTS[22904] = Fluid3D([12609,13602,12851,13343],0); -ELEMENTS[22905] = Fluid3D([12609,13383,13602,13543],0); -ELEMENTS[22906] = Fluid3D([13602,12609,13543,13343],0); -ELEMENTS[22907] = Fluid3D([13543,13602,13343,14183],0); -ELEMENTS[22908] = Fluid3D([13343,13543,14183,14081],0); -ELEMENTS[22909] = Fluid3D([14183,13343,14081,13922],0); -ELEMENTS[22910] = Fluid3D([14081,14183,13922,14690],0); -ELEMENTS[22911] = Fluid3D([14183,13922,14690,14473],0); -ELEMENTS[22912] = Fluid3D([14081,14183,14690,15149],0); -ELEMENTS[22913] = Fluid3D([14183,13343,13922,13602],0); -ELEMENTS[22914] = Fluid3D([12609,13543,13343,12804],0); -ELEMENTS[22915] = Fluid3D([13543,13343,12804,13653],0); -ELEMENTS[22916] = Fluid3D([13543,13343,13653,14081],0); -ELEMENTS[22917] = Fluid3D([13343,13653,14081,13058],0); -ELEMENTS[22918] = Fluid3D([12804,13543,13653,13357],0); -ELEMENTS[22919] = Fluid3D([12804,13543,13357,12816],0); -ELEMENTS[22920] = Fluid3D([13543,13653,13357,14270],0); -ELEMENTS[22921] = Fluid3D([13543,13653,14270,14081],0); -ELEMENTS[22922] = Fluid3D([13357,13543,14270,13771],0); -ELEMENTS[22923] = Fluid3D([13343,12804,13653,13058],0); -ELEMENTS[22924] = Fluid3D([13543,14270,13771,14279],0); -ELEMENTS[22925] = Fluid3D([13543,13602,14183,14279],0); -ELEMENTS[22926] = Fluid3D([13771,13543,14279,13383],0); -ELEMENTS[22927] = Fluid3D([13543,14270,14279,14183],0); -ELEMENTS[22928] = Fluid3D([13653,13357,14270,14042],0); -ELEMENTS[22929] = Fluid3D([14270,13653,14042,14372],0); -ELEMENTS[22930] = Fluid3D([13653,13357,14042,12629],0); -ELEMENTS[22931] = Fluid3D([14270,13653,14372,14081],0); -ELEMENTS[22932] = Fluid3D([13653,14372,14081,13936],0); -ELEMENTS[22933] = Fluid3D([14081,13653,13936,13058],0); -ELEMENTS[22934] = Fluid3D([14372,14081,13936,14650],0); -ELEMENTS[22935] = Fluid3D([14372,14081,14650,15149],0); -ELEMENTS[22936] = Fluid3D([14081,13936,14650,13996],0); -ELEMENTS[22937] = Fluid3D([13936,14650,13996,14475],0); -ELEMENTS[22938] = Fluid3D([13996,13936,14475,13907],0); -ELEMENTS[22939] = Fluid3D([14081,13936,13996,13058],0); -ELEMENTS[22940] = Fluid3D([13936,14475,13907,14780],0); -ELEMENTS[22941] = Fluid3D([13996,13936,13907,13058],0); -ELEMENTS[22942] = Fluid3D([14475,13996,13907,14490],0); -ELEMENTS[22943] = Fluid3D([14650,13996,14475,14490],0); -ELEMENTS[22944] = Fluid3D([14650,14081,13996,14899],0); -ELEMENTS[22945] = Fluid3D([13653,13936,13058,13702],0); -ELEMENTS[22946] = Fluid3D([13936,14650,14475,14780],0); -ELEMENTS[22947] = Fluid3D([13653,14372,13936,14042],0); -ELEMENTS[22948] = Fluid3D([13936,14372,14650,14780],0); -ELEMENTS[22949] = Fluid3D([14650,13996,14490,14899],0); -ELEMENTS[22950] = Fluid3D([13357,13543,13771,12816],0); -ELEMENTS[22951] = Fluid3D([12609,13543,12804,12816],0); -ELEMENTS[22952] = Fluid3D([14270,13357,13771,14148],0); -ELEMENTS[22953] = Fluid3D([14270,13771,14279,14674],0); -ELEMENTS[22954] = Fluid3D([13357,14270,14042,14148],0); -ELEMENTS[22955] = Fluid3D([14042,13357,14148,13498],0); -ELEMENTS[22956] = Fluid3D([14148,14042,13498,13702],0); -ELEMENTS[22957] = Fluid3D([14042,13498,13702,13078],0); -ELEMENTS[22958] = Fluid3D([13498,13702,13078,13199],0); -ELEMENTS[22959] = Fluid3D([14042,13498,13078,13357],0); -ELEMENTS[22960] = Fluid3D([13498,13078,13357,12698],0); -ELEMENTS[22961] = Fluid3D([13498,13078,12698,12662],0); -ELEMENTS[22962] = Fluid3D([13498,13078,12662,13199],0); -ELEMENTS[22963] = Fluid3D([13078,12698,12662,12629],0); -ELEMENTS[22964] = Fluid3D([12662,13078,12629,13199],0); -ELEMENTS[22965] = Fluid3D([13078,12698,12629,12868],0); -ELEMENTS[22966] = Fluid3D([13078,12698,12868,13357],0); -ELEMENTS[22967] = Fluid3D([12698,12868,13357,13309],0); -ELEMENTS[22968] = Fluid3D([12868,13357,13309,12816],0); -ELEMENTS[22969] = Fluid3D([12698,12868,13309,12110],0); -ELEMENTS[22970] = Fluid3D([12698,12868,12110,12168],0); -ELEMENTS[22971] = Fluid3D([12698,12868,12168,12629],0); -ELEMENTS[22972] = Fluid3D([12868,13078,13357,12629],0); -ELEMENTS[22973] = Fluid3D([13078,13357,12629,14042],0); -ELEMENTS[22974] = Fluid3D([12698,13498,12662,12960],0); -ELEMENTS[22975] = Fluid3D([13498,12662,12960,13644],0); -ELEMENTS[22976] = Fluid3D([13498,12662,13644,13199],0); -ELEMENTS[22977] = Fluid3D([12868,12110,12168,12804],0); -ELEMENTS[22978] = Fluid3D([12868,13357,12816,12804],0); -ELEMENTS[22979] = Fluid3D([12868,13357,12804,12629],0); -ELEMENTS[22980] = Fluid3D([12960,13498,13644,14148],0); -ELEMENTS[22981] = Fluid3D([12662,12698,12960,12203],0); -ELEMENTS[22982] = Fluid3D([12960,12662,12203,12753],0); -ELEMENTS[22983] = Fluid3D([12662,12203,12753,11689],0); -ELEMENTS[22984] = Fluid3D([12753,12662,11689,12207],0); -ELEMENTS[22985] = Fluid3D([13309,12868,12816,12110],0); -ELEMENTS[22986] = Fluid3D([12868,12816,12110,12804],0); -ELEMENTS[22987] = Fluid3D([12698,12960,12203,12665],0); -ELEMENTS[22988] = Fluid3D([12960,12203,12665,12649],0); -ELEMENTS[22989] = Fluid3D([12698,12960,12665,13309],0); -ELEMENTS[22990] = Fluid3D([12203,12698,12665,12110],0); -ELEMENTS[22991] = Fluid3D([13702,14042,13078,12629],0); -ELEMENTS[22992] = Fluid3D([12662,12698,12203,11668],0); -ELEMENTS[22993] = Fluid3D([12960,12662,12753,13644],0); -ELEMENTS[22994] = Fluid3D([13078,13702,12629,13199],0); -ELEMENTS[22995] = Fluid3D([12110,12698,12168,11668],0); -ELEMENTS[22996] = Fluid3D([12753,12662,12207,12629],0); -ELEMENTS[22997] = Fluid3D([12168,12868,12804,12629],0); -ELEMENTS[22998] = Fluid3D([13644,13498,13199,13702],0); -ELEMENTS[22999] = Fluid3D([13644,13498,13702,14148],0); -ELEMENTS[23000] = Fluid3D([12168,12110,11668,11699],0); -ELEMENTS[23001] = Fluid3D([11668,12168,11699,11405],0); -ELEMENTS[23002] = Fluid3D([12168,12110,11699,12804],0); -ELEMENTS[23003] = Fluid3D([12168,11699,11405,12093],0); -ELEMENTS[23004] = Fluid3D([12168,11699,12093,12804],0); -ELEMENTS[23005] = Fluid3D([12698,13498,12960,13309],0); -ELEMENTS[23006] = Fluid3D([12168,12698,12629,11668],0); -ELEMENTS[23007] = Fluid3D([12662,12203,11689,11668],0); -ELEMENTS[23008] = Fluid3D([12804,12168,12629,12093],0); -ELEMENTS[23009] = Fluid3D([13357,12698,13309,13498],0); -ELEMENTS[23010] = Fluid3D([11668,12168,11405,12629],0); -ELEMENTS[23011] = Fluid3D([14148,14042,13702,14440],0); -ELEMENTS[23012] = Fluid3D([14042,13702,14440,14929],0); -ELEMENTS[23013] = Fluid3D([12698,12662,12629,11668],0); -ELEMENTS[23014] = Fluid3D([14270,14042,14148,14929],0); -ELEMENTS[23015] = Fluid3D([13383,13602,13543,14279],0); -ELEMENTS[23016] = Fluid3D([12609,13383,13543,12816],0); -ELEMENTS[23017] = Fluid3D([14042,14270,14372,14929],0); -ELEMENTS[23018] = Fluid3D([13653,12804,13357,12629],0); -ELEMENTS[23019] = Fluid3D([12851,12764,12205,11890],0); -ELEMENTS[23020] = Fluid3D([12740,12163,12283,13012],0); -ELEMENTS[23021] = Fluid3D([12182,12163,12740,12911],0); -ELEMENTS[23022] = Fluid3D([12083,12565,11976,12774],0); -ELEMENTS[23023] = Fluid3D([12740,12267,12320,13279],0); -ELEMENTS[23024] = Fluid3D([11325,12083,11842,11495],0); -ELEMENTS[23025] = Fluid3D([12083,11842,11495,12452],0); -ELEMENTS[23026] = Fluid3D([11842,11325,11495,10988],0); -ELEMENTS[23027] = Fluid3D([11325,12083,11495,11316],0); -ELEMENTS[23028] = Fluid3D([12200,12163,13012,12283],0); -ELEMENTS[23029] = Fluid3D([12083,11316,12165,11495],0); -ELEMENTS[23030] = Fluid3D([11976,11373,11325,11087],0); -ELEMENTS[23031] = Fluid3D([11373,12163,12200,11197],0); -ELEMENTS[23032] = Fluid3D([9038,8312,8337,8292],0); -ELEMENTS[23033] = Fluid3D([8312,8337,8292,7624],0); -ELEMENTS[23034] = Fluid3D([8337,9038,8292,9230],0); -ELEMENTS[23035] = Fluid3D([9038,8312,8292,8963],0); -ELEMENTS[23036] = Fluid3D([8431,9418,8814,8720],0); -ELEMENTS[23037] = Fluid3D([10386,10061,11083,10541],0); -ELEMENTS[23038] = Fluid3D([10669,10805,9836,10535],0); -ELEMENTS[23039] = Fluid3D([9426,9813,10287,8866],0); -ELEMENTS[23040] = Fluid3D([9150,9157,8687,9667],0); -ELEMENTS[23041] = Fluid3D([9150,9157,9667,9918],0); -ELEMENTS[23042] = Fluid3D([9157,8687,9667,9352],0); -ELEMENTS[23043] = Fluid3D([8687,9150,9667,9566],0); -ELEMENTS[23044] = Fluid3D([10895,11212,10056,11277],0); -ELEMENTS[23045] = Fluid3D([11316,12200,12165,11890],0); -ELEMENTS[23046] = Fluid3D([10061,9735,10488,10514],0); -ELEMENTS[23047] = Fluid3D([10061,9735,10514,9614],0); -ELEMENTS[23048] = Fluid3D([9735,10488,10514,10056],0); -ELEMENTS[23049] = Fluid3D([10488,10061,10514,11422],0); -ELEMENTS[23050] = Fluid3D([10514,10488,11422,10895],0); -ELEMENTS[23051] = Fluid3D([11422,10514,10895,11593],0); -ELEMENTS[23052] = Fluid3D([11422,10514,11593,11735],0); -ELEMENTS[23053] = Fluid3D([12267,11764,12320,11638],0); -ELEMENTS[23054] = Fluid3D([12320,12267,11638,12410],0); -ELEMENTS[23055] = Fluid3D([12267,11638,12410,11772],0); -ELEMENTS[23056] = Fluid3D([12267,11638,11772,11134],0); -ELEMENTS[23057] = Fluid3D([11638,11772,11134,11123],0); -ELEMENTS[23058] = Fluid3D([11134,11638,11123,10288],0); -ELEMENTS[23059] = Fluid3D([11638,11772,11123,10951],0); -ELEMENTS[23060] = Fluid3D([11123,11638,10951,10288],0); -ELEMENTS[23061] = Fluid3D([12267,11638,11134,11764],0); -ELEMENTS[23062] = Fluid3D([11638,11134,11764,10861],0); -ELEMENTS[23063] = Fluid3D([11772,11123,10951,11613],0); -ELEMENTS[23064] = Fluid3D([11772,11123,11613,11134],0); -ELEMENTS[23065] = Fluid3D([11638,12410,11772,11674],0); -ELEMENTS[23066] = Fluid3D([12410,11772,11674,12490],0); -ELEMENTS[23067] = Fluid3D([11638,12410,11674,12133],0); -ELEMENTS[23068] = Fluid3D([12410,11674,12133,12490],0); -ELEMENTS[23069] = Fluid3D([11772,11638,11674,10951],0); -ELEMENTS[23070] = Fluid3D([11638,11674,10951,12133],0); -ELEMENTS[23071] = Fluid3D([11674,10951,12133,11872],0); -ELEMENTS[23072] = Fluid3D([11674,11772,10951,11547],0); -ELEMENTS[23073] = Fluid3D([10951,11674,11547,11872],0); -ELEMENTS[23074] = Fluid3D([11674,11547,11872,11772],0); -ELEMENTS[23075] = Fluid3D([11547,10951,11872,11007],0); -ELEMENTS[23076] = Fluid3D([11772,11674,12490,11872],0); -ELEMENTS[23077] = Fluid3D([11674,12490,11872,12133],0); -ELEMENTS[23078] = Fluid3D([12490,11772,11872,12167],0); -ELEMENTS[23079] = Fluid3D([11872,12490,12167,12787],0); -ELEMENTS[23080] = Fluid3D([11872,12490,12787,11944],0); -ELEMENTS[23081] = Fluid3D([11547,11872,11772,12167],0); -ELEMENTS[23082] = Fluid3D([11547,11872,12167,12231],0); -ELEMENTS[23083] = Fluid3D([11547,11872,12231,11175],0); -ELEMENTS[23084] = Fluid3D([11547,11872,11175,11007],0); -ELEMENTS[23085] = Fluid3D([12490,11772,12167,13049],0); -ELEMENTS[23086] = Fluid3D([12167,12490,13049,12787],0); -ELEMENTS[23087] = Fluid3D([12410,11772,12490,12949],0); -ELEMENTS[23088] = Fluid3D([12490,13049,12787,12976],0); -ELEMENTS[23089] = Fluid3D([12787,12490,12976,11944],0); -ELEMENTS[23090] = Fluid3D([12410,12267,11772,12949],0); -ELEMENTS[23091] = Fluid3D([12320,12267,12410,13279],0); -ELEMENTS[23092] = Fluid3D([11638,12320,12410,11819],0); -ELEMENTS[23093] = Fluid3D([12320,12410,11819,12793],0); -ELEMENTS[23094] = Fluid3D([12410,11638,11819,12133],0); -ELEMENTS[23095] = Fluid3D([11819,12410,12133,12793],0); -ELEMENTS[23096] = Fluid3D([12133,11819,12793,12195],0); -ELEMENTS[23097] = Fluid3D([11638,12320,11819,11212],0); -ELEMENTS[23098] = Fluid3D([11819,12320,12793,12178],0); -ELEMENTS[23099] = Fluid3D([11819,12320,12178,11212],0); -ELEMENTS[23100] = Fluid3D([12793,11819,12178,12195],0); -ELEMENTS[23101] = Fluid3D([12320,12793,12178,12805],0); -ELEMENTS[23102] = Fluid3D([12320,12410,12793,13279],0); -ELEMENTS[23103] = Fluid3D([11764,12320,11638,11212],0); -ELEMENTS[23104] = Fluid3D([11087,11317,12038,11373],0); -ELEMENTS[23105] = Fluid3D([9418,9028,9918,9724],0); -ELEMENTS[23106] = Fluid3D([9802,10056,9164,9735],0); -ELEMENTS[23107] = Fluid3D([8034,8324,8442,7773],0); -ELEMENTS[23108] = Fluid3D([8324,8442,7773,8631],0); -ELEMENTS[23109] = Fluid3D([8324,8442,8631,9447],0); -ELEMENTS[23110] = Fluid3D([7773,8324,8631,8596],0); -ELEMENTS[23111] = Fluid3D([8885,9573,9588,8926],0); -ELEMENTS[23112] = Fluid3D([11990,11152,11291,12143],0); -ELEMENTS[23113] = Fluid3D([8687,8160,8336,7760],0); -ELEMENTS[23114] = Fluid3D([8687,8160,7760,8360],0); -ELEMENTS[23115] = Fluid3D([8160,8336,7760,7599],0); -ELEMENTS[23116] = Fluid3D([8336,8687,7760,8151],0); -ELEMENTS[23117] = Fluid3D([8687,7760,8151,8411],0); -ELEMENTS[23118] = Fluid3D([8687,7760,8411,8360],0); -ELEMENTS[23119] = Fluid3D([8411,8687,8360,9352],0); -ELEMENTS[23120] = Fluid3D([8411,8687,9352,8832],0); -ELEMENTS[23121] = Fluid3D([8411,8687,8832,8151],0); -ELEMENTS[23122] = Fluid3D([7760,8411,8360,7657],0); -ELEMENTS[23123] = Fluid3D([8411,8360,7657,8863],0); -ELEMENTS[23124] = Fluid3D([8411,8360,8863,9352],0); -ELEMENTS[23125] = Fluid3D([7760,8411,7657,7730],0); -ELEMENTS[23126] = Fluid3D([8411,7657,7730,8007],0); -ELEMENTS[23127] = Fluid3D([7730,8411,8007,8832],0); -ELEMENTS[23128] = Fluid3D([7657,7730,8007,7143],0); -ELEMENTS[23129] = Fluid3D([7730,8007,7143,8002],0); -ELEMENTS[23130] = Fluid3D([7730,8007,8002,8832],0); -ELEMENTS[23131] = Fluid3D([7143,7730,8002,8151],0); -ELEMENTS[23132] = Fluid3D([7760,8411,7730,8151],0); -ELEMENTS[23133] = Fluid3D([8336,8687,8151,9566],0); -ELEMENTS[23134] = Fluid3D([7760,8336,8151,7582],0); -ELEMENTS[23135] = Fluid3D([8151,7760,7582,7730],0); -ELEMENTS[23136] = Fluid3D([8336,8151,7582,8259],0); -ELEMENTS[23137] = Fluid3D([8336,8151,8259,9075],0); -ELEMENTS[23138] = Fluid3D([8259,8336,9075,8814],0); -ELEMENTS[23139] = Fluid3D([7760,8336,7582,7599],0); -ELEMENTS[23140] = Fluid3D([7582,8336,8259,7809],0); -ELEMENTS[23141] = Fluid3D([8336,8259,7809,8814],0); -ELEMENTS[23142] = Fluid3D([7582,8336,7809,7599],0); -ELEMENTS[23143] = Fluid3D([8259,7582,7809,7313],0); -ELEMENTS[23144] = Fluid3D([7809,8259,7313,8028],0); -ELEMENTS[23145] = Fluid3D([8259,7582,7313,7539],0); -ELEMENTS[23146] = Fluid3D([8259,7582,7539,8151],0); -ELEMENTS[23147] = Fluid3D([7313,7809,8028,7263],0); -ELEMENTS[23148] = Fluid3D([7313,7809,7263,7026],0); -ELEMENTS[23149] = Fluid3D([7313,7809,7026,7582],0); -ELEMENTS[23150] = Fluid3D([8028,7313,7263,7317],0); -ELEMENTS[23151] = Fluid3D([7313,7263,7317,6586],0); -ELEMENTS[23152] = Fluid3D([7313,7263,6586,7026],0); -ELEMENTS[23153] = Fluid3D([8028,7313,7317,7841],0); -ELEMENTS[23154] = Fluid3D([7317,8028,7841,8157],0); -ELEMENTS[23155] = Fluid3D([7317,8028,8157,7795],0); -ELEMENTS[23156] = Fluid3D([7317,8028,7795,7263],0); -ELEMENTS[23157] = Fluid3D([8028,7313,7841,8259],0); -ELEMENTS[23158] = Fluid3D([7317,7313,6586,6909],0); -ELEMENTS[23159] = Fluid3D([7313,6586,6909,6539],0); -ELEMENTS[23160] = Fluid3D([7313,6586,6539,7026],0); -ELEMENTS[23161] = Fluid3D([6586,7317,6909,6599],0); -ELEMENTS[23162] = Fluid3D([6586,7317,6599,6762],0); -ELEMENTS[23163] = Fluid3D([6586,7317,6762,7263],0); -ELEMENTS[23164] = Fluid3D([7317,7313,6909,7841],0); -ELEMENTS[23165] = Fluid3D([7317,6909,6599,7035],0); -ELEMENTS[23166] = Fluid3D([7809,8259,8028,8529],0); -ELEMENTS[23167] = Fluid3D([7809,8259,8529,8814],0); -ELEMENTS[23168] = Fluid3D([8259,8028,8529,8913],0); -ELEMENTS[23169] = Fluid3D([8028,7809,8529,8074],0); -ELEMENTS[23170] = Fluid3D([8259,8028,8913,7841],0); -ELEMENTS[23171] = Fluid3D([8529,8028,8074,8839],0); -ELEMENTS[23172] = Fluid3D([8028,8074,8839,7795],0); -ELEMENTS[23173] = Fluid3D([8529,8028,8839,8913],0); -ELEMENTS[23174] = Fluid3D([8028,7809,8074,7263],0); -ELEMENTS[23175] = Fluid3D([8529,7809,8814,8074],0); -ELEMENTS[23176] = Fluid3D([8814,8529,8074,9246],0); -ELEMENTS[23177] = Fluid3D([8814,8529,9246,9472],0); -ELEMENTS[23178] = Fluid3D([8814,8529,9472,8259],0); -ELEMENTS[23179] = Fluid3D([8529,9246,9472,8913],0); -ELEMENTS[23180] = Fluid3D([9472,8529,8913,8259],0); -ELEMENTS[23181] = Fluid3D([9246,8814,9472,9954],0); -ELEMENTS[23182] = Fluid3D([8529,8074,9246,8839],0); -ELEMENTS[23183] = Fluid3D([9246,8529,8839,8913],0); -ELEMENTS[23184] = Fluid3D([8074,9246,8839,8797],0); -ELEMENTS[23185] = Fluid3D([9246,8839,8797,9538],0); -ELEMENTS[23186] = Fluid3D([9246,8839,9538,9503],0); -ELEMENTS[23187] = Fluid3D([9246,8839,9503,8913],0); -ELEMENTS[23188] = Fluid3D([8839,9538,9503,9052],0); -ELEMENTS[23189] = Fluid3D([8839,8797,9538,8691],0); -ELEMENTS[23190] = Fluid3D([9538,9246,9503,10094],0); -ELEMENTS[23191] = Fluid3D([8839,9538,9052,8691],0); -ELEMENTS[23192] = Fluid3D([9052,8839,8691,8157],0); -ELEMENTS[23193] = Fluid3D([9538,9052,8691,9634],0); -ELEMENTS[23194] = Fluid3D([8839,8797,8691,7795],0); -ELEMENTS[23195] = Fluid3D([9246,9503,10094,9472],0); -ELEMENTS[23196] = Fluid3D([9246,9503,9472,8913],0); -ELEMENTS[23197] = Fluid3D([9503,9472,8913,9648],0); -ELEMENTS[23198] = Fluid3D([9503,8839,9052,8913],0); -ELEMENTS[23199] = Fluid3D([8797,9246,9538,9683],0); -ELEMENTS[23200] = Fluid3D([9538,9246,10094,9683],0); -ELEMENTS[23201] = Fluid3D([9246,10094,9683,9954],0); -ELEMENTS[23202] = Fluid3D([8797,9246,9683,8886],0); -ELEMENTS[23203] = Fluid3D([8797,9246,8886,8074],0); -ELEMENTS[23204] = Fluid3D([10094,9538,9683,10480],0); -ELEMENTS[23205] = Fluid3D([9683,10094,10480,10633],0); -ELEMENTS[23206] = Fluid3D([9683,10094,10633,9954],0); -ELEMENTS[23207] = Fluid3D([9246,9683,8886,9954],0); -ELEMENTS[23208] = Fluid3D([8839,8074,8797,7795],0); -ELEMENTS[23209] = Fluid3D([10480,9683,10633,10374],0); -ELEMENTS[23210] = Fluid3D([10480,9683,10374,9692],0); -ELEMENTS[23211] = Fluid3D([10480,9683,9692,9538],0); -ELEMENTS[23212] = Fluid3D([9503,10094,9472,10345],0); -ELEMENTS[23213] = Fluid3D([9472,9503,10345,9648],0); -ELEMENTS[23214] = Fluid3D([10094,10480,10633,11114],0); -ELEMENTS[23215] = Fluid3D([10633,10094,11114,10893],0); -ELEMENTS[23216] = Fluid3D([10094,10480,11114,10515],0); -ELEMENTS[23217] = Fluid3D([10094,10480,10515,9538],0); -ELEMENTS[23218] = Fluid3D([9683,10633,10374,10006],0); -ELEMENTS[23219] = Fluid3D([9683,10633,10006,9954],0); -ELEMENTS[23220] = Fluid3D([9538,9503,9052,10515],0); -ELEMENTS[23221] = Fluid3D([10374,9683,10006,9404],0); -ELEMENTS[23222] = Fluid3D([8797,9538,8691,9692],0); -ELEMENTS[23223] = Fluid3D([10633,10480,10374,11312],0); -ELEMENTS[23224] = Fluid3D([10480,10633,11114,11312],0); -ELEMENTS[23225] = Fluid3D([10374,10633,11312,10925],0); -ELEMENTS[23226] = Fluid3D([10374,10633,10925,10006],0); -ELEMENTS[23227] = Fluid3D([10480,10374,11312,10922],0); -ELEMENTS[23228] = Fluid3D([10480,10374,10922,9692],0); -ELEMENTS[23229] = Fluid3D([11114,10094,10515,10345],0); -ELEMENTS[23230] = Fluid3D([9538,8797,9683,9692],0); -ELEMENTS[23231] = Fluid3D([9503,9538,10094,10515],0); -ELEMENTS[23232] = Fluid3D([9683,10374,9692,9325],0); -ELEMENTS[23233] = Fluid3D([10480,11114,10515,11269],0); -ELEMENTS[23234] = Fluid3D([10515,10480,11269,10718],0); -ELEMENTS[23235] = Fluid3D([10480,11114,11269,11312],0); -ELEMENTS[23236] = Fluid3D([9503,10094,10345,10515],0); -ELEMENTS[23237] = Fluid3D([9683,8797,8886,8576],0); -ELEMENTS[23238] = Fluid3D([11312,10374,10925,11222],0); -ELEMENTS[23239] = Fluid3D([10925,11312,11222,12081],0); -ELEMENTS[23240] = Fluid3D([11312,11222,12081,12052],0); -ELEMENTS[23241] = Fluid3D([10094,10633,9954,10893],0); -ELEMENTS[23242] = Fluid3D([10374,11312,10922,11222],0); -ELEMENTS[23243] = Fluid3D([10633,11312,10925,11515],0); -ELEMENTS[23244] = Fluid3D([10633,11312,11515,11114],0); -ELEMENTS[23245] = Fluid3D([11312,10925,11515,12081],0); -ELEMENTS[23246] = Fluid3D([11515,11312,12081,12487],0); -ELEMENTS[23247] = Fluid3D([10925,10633,11515,11152],0); -ELEMENTS[23248] = Fluid3D([11114,10515,11269,11360],0); -ELEMENTS[23249] = Fluid3D([10515,11269,11360,10603],0); -ELEMENTS[23250] = Fluid3D([11114,10515,11360,10345],0); -ELEMENTS[23251] = Fluid3D([11269,11114,11360,12022],0); -ELEMENTS[23252] = Fluid3D([11360,11269,12022,11589],0); -ELEMENTS[23253] = Fluid3D([11269,11114,12022,11312],0); -ELEMENTS[23254] = Fluid3D([11114,11360,12022,11763],0); -ELEMENTS[23255] = Fluid3D([11360,12022,11763,12440],0); -ELEMENTS[23256] = Fluid3D([11360,12022,12440,12353],0); -ELEMENTS[23257] = Fluid3D([12022,12440,12353,12951],0); -ELEMENTS[23258] = Fluid3D([12440,12353,12951,12778],0); -ELEMENTS[23259] = Fluid3D([12951,12440,12778,13372],0); -ELEMENTS[23260] = Fluid3D([12951,12440,13372,12983],0); -ELEMENTS[23261] = Fluid3D([12353,12951,12778,12692],0); -ELEMENTS[23262] = Fluid3D([12022,12440,12951,12983],0); -ELEMENTS[23263] = Fluid3D([12353,12951,12692,12487],0); -ELEMENTS[23264] = Fluid3D([12440,12353,12778,11858],0); -ELEMENTS[23265] = Fluid3D([12778,12353,12692,11858],0); -ELEMENTS[23266] = Fluid3D([11114,11360,11763,10345],0); -ELEMENTS[23267] = Fluid3D([11360,12022,12353,11589],0); -ELEMENTS[23268] = Fluid3D([12353,11360,11589,11858],0); -ELEMENTS[23269] = Fluid3D([11589,12353,11858,12692],0); -ELEMENTS[23270] = Fluid3D([11589,12353,12692,12170],0); -ELEMENTS[23271] = Fluid3D([12022,11114,11763,11515],0); -ELEMENTS[23272] = Fluid3D([12022,11763,12440,12983],0); -ELEMENTS[23273] = Fluid3D([7313,8259,7539,7841],0); -ELEMENTS[23274] = Fluid3D([8157,7317,7795,7819],0); -ELEMENTS[23275] = Fluid3D([7795,8157,7819,8691],0); -ELEMENTS[23276] = Fluid3D([6909,7313,6539,7539],0); -ELEMENTS[23277] = Fluid3D([11312,10480,10922,11269],0); -ELEMENTS[23278] = Fluid3D([8151,8259,9075,8575],0); -ELEMENTS[23279] = Fluid3D([8151,8259,8575,7539],0); -ELEMENTS[23280] = Fluid3D([9075,8151,8575,9434],0); -ELEMENTS[23281] = Fluid3D([8259,9075,8575,9648],0); -ELEMENTS[23282] = Fluid3D([7582,7313,7539,6539],0); -ELEMENTS[23283] = Fluid3D([7841,7317,8157,7838],0); -ELEMENTS[23284] = Fluid3D([7317,8157,7838,7819],0); -ELEMENTS[23285] = Fluid3D([8157,7838,7819,8718],0); -ELEMENTS[23286] = Fluid3D([8157,7838,8718,8749],0); -ELEMENTS[23287] = Fluid3D([8157,7841,7838,8749],0); -ELEMENTS[23288] = Fluid3D([7819,8157,8718,8691],0); -ELEMENTS[23289] = Fluid3D([11763,11360,12440,11880],0); -ELEMENTS[23290] = Fluid3D([11360,12440,11880,11858],0); -ELEMENTS[23291] = Fluid3D([11763,11360,11880,10345],0); -ELEMENTS[23292] = Fluid3D([12440,11763,11880,12568],0); -ELEMENTS[23293] = Fluid3D([11880,12440,12568,12856],0); -ELEMENTS[23294] = Fluid3D([11763,11880,12568,12059],0); -ELEMENTS[23295] = Fluid3D([12440,11763,12568,12983],0); -ELEMENTS[23296] = Fluid3D([8336,8151,9075,9566],0); -ELEMENTS[23297] = Fluid3D([6586,6909,6539,6110],0); -ELEMENTS[23298] = Fluid3D([6586,6909,6110,6599],0); -ELEMENTS[23299] = Fluid3D([6539,6586,6110,5976],0); -ELEMENTS[23300] = Fluid3D([6586,6110,5976,5791],0); -ELEMENTS[23301] = Fluid3D([6909,6539,6110,6429],0); -ELEMENTS[23302] = Fluid3D([6110,6909,6429,6260],0); -ELEMENTS[23303] = Fluid3D([6539,6110,6429,5902],0); -ELEMENTS[23304] = Fluid3D([6539,6110,5902,5976],0); -ELEMENTS[23305] = Fluid3D([6110,6429,5902,5671],0); -ELEMENTS[23306] = Fluid3D([6909,6539,6429,7539],0); -ELEMENTS[23307] = Fluid3D([6539,6586,5976,7026],0); -ELEMENTS[23308] = Fluid3D([7317,6599,6762,7014],0); -ELEMENTS[23309] = Fluid3D([7317,6599,7014,7035],0); -ELEMENTS[23310] = Fluid3D([6599,6762,7014,6552],0); -ELEMENTS[23311] = Fluid3D([6599,7014,7035,6240],0); -ELEMENTS[23312] = Fluid3D([6599,7014,6240,5866],0); -ELEMENTS[23313] = Fluid3D([7035,6599,6240,6110],0); -ELEMENTS[23314] = Fluid3D([6599,6240,6110,5791],0); -ELEMENTS[23315] = Fluid3D([6240,6599,5866,5791],0); -ELEMENTS[23316] = Fluid3D([6429,6539,5902,6462],0); -ELEMENTS[23317] = Fluid3D([6539,5902,6462,6168],0); -ELEMENTS[23318] = Fluid3D([6429,6539,6462,7539],0); -ELEMENTS[23319] = Fluid3D([5902,6462,6168,5654],0); -ELEMENTS[23320] = Fluid3D([6168,5902,5654,5976],0); -ELEMENTS[23321] = Fluid3D([5902,6462,5654,5845],0); -ELEMENTS[23322] = Fluid3D([5654,5902,5845,5207],0); -ELEMENTS[23323] = Fluid3D([5654,5902,5207,5319],0); -ELEMENTS[23324] = Fluid3D([5654,5902,5319,5976],0); -ELEMENTS[23325] = Fluid3D([5207,5654,5319,5033],0); -ELEMENTS[23326] = Fluid3D([5654,5319,5033,5307],0); -ELEMENTS[23327] = Fluid3D([5902,6429,6462,5845],0); -ELEMENTS[23328] = Fluid3D([6462,6539,6168,6938],0); -ELEMENTS[23329] = Fluid3D([6462,6539,6938,7539],0); -ELEMENTS[23330] = Fluid3D([6539,6168,6938,7026],0); -ELEMENTS[23331] = Fluid3D([6168,6462,6938,6412],0); -ELEMENTS[23332] = Fluid3D([6539,5902,6168,5976],0); -ELEMENTS[23333] = Fluid3D([12440,11360,12353,11858],0); -ELEMENTS[23334] = Fluid3D([7809,7263,7026,7270],0); -ELEMENTS[23335] = Fluid3D([7809,7263,7270,8074],0); -ELEMENTS[23336] = Fluid3D([7026,7809,7270,7599],0); -ELEMENTS[23337] = Fluid3D([7263,7026,7270,6407],0); -ELEMENTS[23338] = Fluid3D([8028,7841,8157,8913],0); -ELEMENTS[23339] = Fluid3D([10374,10925,11222,10225],0); -ELEMENTS[23340] = Fluid3D([8028,8157,7795,8839],0); -ELEMENTS[23341] = Fluid3D([6599,6586,6762,5791],0); -ELEMENTS[23342] = Fluid3D([10858,9918,10591,9614],0); -ELEMENTS[23343] = Fluid3D([10056,11212,10861,10288],0); -ELEMENTS[23344] = Fluid3D([10386,10488,10186,11285],0); -ELEMENTS[23345] = Fluid3D([11477,11785,11682,12416],0); -ELEMENTS[23346] = Fluid3D([11682,11477,12416,11947],0); -ELEMENTS[23347] = Fluid3D([11477,11785,12416,11990],0); -ELEMENTS[23348] = Fluid3D([11477,12416,11947,11993],0); -ELEMENTS[23349] = Fluid3D([11682,11477,11947,10796],0); -ELEMENTS[23350] = Fluid3D([12416,11682,11947,12762],0); -ELEMENTS[23351] = Fluid3D([11785,11682,12416,12561],0); -ELEMENTS[23352] = Fluid3D([11682,12416,12561,12963],0); -ELEMENTS[23353] = Fluid3D([11785,11682,12561,11735],0); -ELEMENTS[23354] = Fluid3D([11682,12561,11735,12282],0); -ELEMENTS[23355] = Fluid3D([12561,11735,12282,12948],0); -ELEMENTS[23356] = Fluid3D([12282,12561,12948,12963],0); -ELEMENTS[23357] = Fluid3D([12948,12282,12963,13057],0); -ELEMENTS[23358] = Fluid3D([12561,12948,12963,13601],0); -ELEMENTS[23359] = Fluid3D([12282,12561,12963,11682],0); -ELEMENTS[23360] = Fluid3D([11735,11682,12282,11287],0); -ELEMENTS[23361] = Fluid3D([11735,11682,11287,10591],0); -ELEMENTS[23362] = Fluid3D([12282,11735,11287,12228],0); -ELEMENTS[23363] = Fluid3D([11682,11287,10591,11234],0); -ELEMENTS[23364] = Fluid3D([11287,10591,11234,10541],0); -ELEMENTS[23365] = Fluid3D([12561,11785,11735,12324],0); -ELEMENTS[23366] = Fluid3D([11735,12561,12324,12385],0); -ELEMENTS[23367] = Fluid3D([12282,11735,12228,12948],0); -ELEMENTS[23368] = Fluid3D([12228,12282,12948,13057],0); -ELEMENTS[23369] = Fluid3D([11682,11287,11234,12282],0); -ELEMENTS[23370] = Fluid3D([12561,11735,12948,12385],0); -ELEMENTS[23371] = Fluid3D([12561,11785,12324,13202],0); -ELEMENTS[23372] = Fluid3D([12416,11785,12561,13202],0); -ELEMENTS[23373] = Fluid3D([10544,11317,11087,10287],0); -ELEMENTS[23374] = Fluid3D([11990,11477,11993,12416],0); -ELEMENTS[23375] = Fluid3D([7881,8474,8728,8266],0); -ELEMENTS[23376] = Fluid3D([8266,8755,8728,8982],0); -ELEMENTS[23377] = Fluid3D([8265,8767,8370,8080],0); -ELEMENTS[23378] = Fluid3D([8265,8767,8080,7678],0); -ELEMENTS[23379] = Fluid3D([8080,8265,7678,8370],0); -ELEMENTS[23380] = Fluid3D([8767,8370,8080,8651],0); -ELEMENTS[23381] = Fluid3D([9696,10656,10540,10509],0); -ELEMENTS[23382] = Fluid3D([17597,17308,17600,17612],0); -ELEMENTS[23383] = Fluid3D([17308,17600,17612,17475],0); -ELEMENTS[23384] = Fluid3D([17597,17308,17612,17390],0); -ELEMENTS[23385] = Fluid3D([17600,17612,17475,17804],0); -ELEMENTS[23386] = Fluid3D([17600,17597,17612,17894],0); -ELEMENTS[23387] = Fluid3D([17597,17612,17894,17774],0); -ELEMENTS[23388] = Fluid3D([17894,17597,17774,17893],0); -ELEMENTS[23389] = Fluid3D([17600,17597,17894,17785],0); -ELEMENTS[23390] = Fluid3D([17894,17600,17785,17919],0); -ELEMENTS[23391] = Fluid3D([17600,17597,17785,17372],0); -ELEMENTS[23392] = Fluid3D([17785,17894,17919,18193],0); -ELEMENTS[23393] = Fluid3D([17894,17600,17919,17804],0); -ELEMENTS[23394] = Fluid3D([17597,17894,17785,17893],0); -ELEMENTS[23395] = Fluid3D([17308,17600,17475,17175],0); -ELEMENTS[23396] = Fluid3D([17612,17308,17475,17259],0); -ELEMENTS[23397] = Fluid3D([17612,17308,17259,17321],0); -ELEMENTS[23398] = Fluid3D([17308,17475,17259,16803],0); -ELEMENTS[23399] = Fluid3D([17308,17259,17321,16885],0); -ELEMENTS[23400] = Fluid3D([17475,17612,17259,17586],0); -ELEMENTS[23401] = Fluid3D([17612,17259,17586,17581],0); -ELEMENTS[23402] = Fluid3D([17259,17475,17586,17212],0); -ELEMENTS[23403] = Fluid3D([17259,17586,17581,17345],0); -ELEMENTS[23404] = Fluid3D([17259,17586,17345,17212],0); -ELEMENTS[23405] = Fluid3D([17475,17612,17586,17844],0); -ELEMENTS[23406] = Fluid3D([17612,17586,17844,17945],0); -ELEMENTS[23407] = Fluid3D([17612,17586,17945,17581],0); -ELEMENTS[23408] = Fluid3D([17475,17612,17844,17804],0); -ELEMENTS[23409] = Fluid3D([17586,17581,17345,17725],0); -ELEMENTS[23410] = Fluid3D([17345,17586,17725,17539],0); -ELEMENTS[23411] = Fluid3D([17725,17345,17539,17548],0); -ELEMENTS[23412] = Fluid3D([17725,17345,17548,17531],0); -ELEMENTS[23413] = Fluid3D([17586,17581,17725,17945],0); -ELEMENTS[23414] = Fluid3D([17345,17586,17539,17212],0); -ELEMENTS[23415] = Fluid3D([17581,17345,17725,17531],0); -ELEMENTS[23416] = Fluid3D([17612,17259,17581,17321],0); -ELEMENTS[23417] = Fluid3D([17475,17586,17212,17592],0); -ELEMENTS[23418] = Fluid3D([17539,17725,17548,17801],0); -ELEMENTS[23419] = Fluid3D([17725,17548,17801,17776],0); -ELEMENTS[23420] = Fluid3D([17548,17539,17801,17509],0); -ELEMENTS[23421] = Fluid3D([17548,17539,17509,17170],0); -ELEMENTS[23422] = Fluid3D([17801,17548,17509,17688],0); -ELEMENTS[23423] = Fluid3D([17539,17725,17801,17903],0); -ELEMENTS[23424] = Fluid3D([17509,17548,17170,17243],0); -ELEMENTS[23425] = Fluid3D([17509,17548,17243,17688],0); -ELEMENTS[23426] = Fluid3D([17539,17725,17903,17586],0); -ELEMENTS[23427] = Fluid3D([17548,17539,17170,17345],0); -ELEMENTS[23428] = Fluid3D([17801,17548,17688,17800],0); -ELEMENTS[23429] = Fluid3D([17801,17548,17800,17776],0); -ELEMENTS[23430] = Fluid3D([17548,17800,17776,17675],0); -ELEMENTS[23431] = Fluid3D([17800,17776,17675,18000],0); -ELEMENTS[23432] = Fluid3D([17800,17776,18000,18083],0); -ELEMENTS[23433] = Fluid3D([17675,17800,18000,17688],0); -ELEMENTS[23434] = Fluid3D([17800,17776,18083,17801],0); -ELEMENTS[23435] = Fluid3D([18000,17800,18083,18022],0); -ELEMENTS[23436] = Fluid3D([18000,17800,18022,17688],0); -ELEMENTS[23437] = Fluid3D([17688,17801,17800,18022],0); -ELEMENTS[23438] = Fluid3D([17801,17800,18022,18083],0); -ELEMENTS[23439] = Fluid3D([17801,17539,17903,17793],0); -ELEMENTS[23440] = Fluid3D([17801,17539,17793,17509],0); -ELEMENTS[23441] = Fluid3D([17539,17903,17793,17653],0); -ELEMENTS[23442] = Fluid3D([17539,17903,17653,17586],0); -ELEMENTS[23443] = Fluid3D([17793,17539,17653,17420],0); -ELEMENTS[23444] = Fluid3D([17539,17653,17420,17212],0); -ELEMENTS[23445] = Fluid3D([17793,17539,17420,17509],0); -ELEMENTS[23446] = Fluid3D([17903,17801,17793,18060],0); -ELEMENTS[23447] = Fluid3D([17903,17801,18060,18022],0); -ELEMENTS[23448] = Fluid3D([17801,18060,18022,17966],0); -ELEMENTS[23449] = Fluid3D([18022,17801,17966,17688],0); -ELEMENTS[23450] = Fluid3D([17801,18060,17966,17793],0); -ELEMENTS[23451] = Fluid3D([18060,18022,17966,18210],0); -ELEMENTS[23452] = Fluid3D([18022,17966,18210,18094],0); -ELEMENTS[23453] = Fluid3D([18022,17966,18094,17688],0); -ELEMENTS[23454] = Fluid3D([18210,18022,18094,18260],0); -ELEMENTS[23455] = Fluid3D([17966,18210,18094,18212],0); -ELEMENTS[23456] = Fluid3D([18210,18094,18212,18401],0); -ELEMENTS[23457] = Fluid3D([17793,17903,18060,18050],0); -ELEMENTS[23458] = Fluid3D([17903,18060,18050,18166],0); -ELEMENTS[23459] = Fluid3D([17903,18060,18166,18082],0); -ELEMENTS[23460] = Fluid3D([17903,18060,18082,18022],0); -ELEMENTS[23461] = Fluid3D([18060,18082,18022,18210],0); -ELEMENTS[23462] = Fluid3D([18166,17903,18082,17945],0); -ELEMENTS[23463] = Fluid3D([17793,17903,18050,17653],0); -ELEMENTS[23464] = Fluid3D([18060,17793,18050,17980],0); -ELEMENTS[23465] = Fluid3D([17793,18050,17980,17788],0); -ELEMENTS[23466] = Fluid3D([18050,17980,17788,18132],0); -ELEMENTS[23467] = Fluid3D([18050,17980,18132,18333],0); -ELEMENTS[23468] = Fluid3D([18060,17793,17980,17966],0); -ELEMENTS[23469] = Fluid3D([17980,17788,18132,17995],0); -ELEMENTS[23470] = Fluid3D([18132,17980,17995,18252],0); -ELEMENTS[23471] = Fluid3D([17980,17788,17995,17716],0); -ELEMENTS[23472] = Fluid3D([17788,18132,17995,17999],0); -ELEMENTS[23473] = Fluid3D([17980,17788,17716,17793],0); -ELEMENTS[23474] = Fluid3D([17788,17995,17716,17604],0); -ELEMENTS[23475] = Fluid3D([17995,17716,17604,17747],0); -ELEMENTS[23476] = Fluid3D([17995,17716,17747,17930],0); -ELEMENTS[23477] = Fluid3D([17716,17604,17747,17355],0); -ELEMENTS[23478] = Fluid3D([17716,17604,17355,17420],0); -ELEMENTS[23479] = Fluid3D([17604,17747,17355,17443],0); -ELEMENTS[23480] = Fluid3D([17747,17355,17443,17244],0); -ELEMENTS[23481] = Fluid3D([17788,17995,17604,17865],0); -ELEMENTS[23482] = Fluid3D([17995,17604,17865,17830],0); -ELEMENTS[23483] = Fluid3D([17865,17995,17830,18107],0); -ELEMENTS[23484] = Fluid3D([17865,17995,18107,17999],0); -ELEMENTS[23485] = Fluid3D([18107,17865,17999,18037],0); -ELEMENTS[23486] = Fluid3D([17865,17999,18037,17833],0); -ELEMENTS[23487] = Fluid3D([17865,17999,17833,17701],0); -ELEMENTS[23488] = Fluid3D([17865,17999,17701,17788],0); -ELEMENTS[23489] = Fluid3D([17865,17999,17788,17995],0); -ELEMENTS[23490] = Fluid3D([17604,17747,17443,17830],0); -ELEMENTS[23491] = Fluid3D([17995,17604,17830,17747],0); -ELEMENTS[23492] = Fluid3D([18050,18060,17980,18333],0); -ELEMENTS[23493] = Fluid3D([17793,18050,17788,17653],0); -ELEMENTS[23494] = Fluid3D([17716,17788,17604,17420],0); -ELEMENTS[23495] = Fluid3D([17747,17716,17355,17671],0); -ELEMENTS[23496] = Fluid3D([17747,17716,17671,17930],0); -ELEMENTS[23497] = Fluid3D([17716,17355,17671,17367],0); -ELEMENTS[23498] = Fluid3D([17716,17355,17367,17420],0); -ELEMENTS[23499] = Fluid3D([17671,17716,17367,17803],0); -ELEMENTS[23500] = Fluid3D([17671,17716,17803,17930],0); -ELEMENTS[23501] = Fluid3D([17716,17803,17930,17793],0); -ELEMENTS[23502] = Fluid3D([17716,17367,17803,17793],0); -ELEMENTS[23503] = Fluid3D([17355,17747,17671,17244],0); -ELEMENTS[23504] = Fluid3D([17355,17671,17367,17244],0); -ELEMENTS[23505] = Fluid3D([17367,17671,17803,17553],0); -ELEMENTS[23506] = Fluid3D([17671,17803,17553,17909],0); -ELEMENTS[23507] = Fluid3D([17367,17671,17553,17192],0); -ELEMENTS[23508] = Fluid3D([17803,17553,17909,17852],0); -ELEMENTS[23509] = Fluid3D([17909,17803,17852,18007],0); -ELEMENTS[23510] = Fluid3D([17909,17803,18007,17930],0); -ELEMENTS[23511] = Fluid3D([17803,17852,18007,17966],0); -ELEMENTS[23512] = Fluid3D([18007,17803,17966,17930],0); -ELEMENTS[23513] = Fluid3D([17852,17909,18007,18102],0); -ELEMENTS[23514] = Fluid3D([17852,18007,17966,18212],0); -ELEMENTS[23515] = Fluid3D([17803,17852,17966,17688],0); -ELEMENTS[23516] = Fluid3D([17671,17553,17192,17433],0); -ELEMENTS[23517] = Fluid3D([17192,17671,17433,17244],0); -ELEMENTS[23518] = Fluid3D([17433,17192,17244,17114],0); -ELEMENTS[23519] = Fluid3D([17192,17244,17114,16992],0); -ELEMENTS[23520] = Fluid3D([17192,17244,16992,17367],0); -ELEMENTS[23521] = Fluid3D([17433,17192,17114,17260],0); -ELEMENTS[23522] = Fluid3D([17114,17192,16992,16756],0); -ELEMENTS[23523] = Fluid3D([17192,17114,17260,16756],0); -ELEMENTS[23524] = Fluid3D([17433,17192,17260,17553],0); -ELEMENTS[23525] = Fluid3D([17192,17260,17553,17185],0); -ELEMENTS[23526] = Fluid3D([17260,17553,17185,17391],0); -ELEMENTS[23527] = Fluid3D([17260,17553,17391,17712],0); -ELEMENTS[23528] = Fluid3D([17260,17553,17712,17433],0); -ELEMENTS[23529] = Fluid3D([17185,17260,17391,16936],0); -ELEMENTS[23530] = Fluid3D([17391,17260,17712,17296],0); -ELEMENTS[23531] = Fluid3D([17391,17260,17296,16936],0); -ELEMENTS[23532] = Fluid3D([17260,17712,17296,17433],0); -ELEMENTS[23533] = Fluid3D([17296,17260,17433,17114],0); -ELEMENTS[23534] = Fluid3D([17296,17260,17114,16756],0); -ELEMENTS[23535] = Fluid3D([17296,17260,16756,16936],0); -ELEMENTS[23536] = Fluid3D([17553,17391,17712,17852],0); -ELEMENTS[23537] = Fluid3D([17192,17260,17185,16756],0); -ELEMENTS[23538] = Fluid3D([17553,17185,17391,17523],0); -ELEMENTS[23539] = Fluid3D([17391,17553,17523,17852],0); -ELEMENTS[23540] = Fluid3D([17553,17185,17523,17367],0); -ELEMENTS[23541] = Fluid3D([17244,17114,16992,16831],0); -ELEMENTS[23542] = Fluid3D([17553,17192,17185,17367],0); -ELEMENTS[23543] = Fluid3D([16992,17244,16831,16924],0); -ELEMENTS[23544] = Fluid3D([16992,17244,16924,17355],0); -ELEMENTS[23545] = Fluid3D([17712,17553,17852,17909],0); -ELEMENTS[23546] = Fluid3D([17185,17391,17523,17243],0); -ELEMENTS[23547] = Fluid3D([17244,16831,16924,17113],0); -ELEMENTS[23548] = Fluid3D([16924,17244,17113,17443],0); -ELEMENTS[23549] = Fluid3D([17244,16831,17113,17236],0); -ELEMENTS[23550] = Fluid3D([17803,17553,17852,17523],0); -ELEMENTS[23551] = Fluid3D([17367,17671,17192,17244],0); -ELEMENTS[23552] = Fluid3D([17803,17367,17553,17523],0); -ELEMENTS[23553] = Fluid3D([17671,17803,17909,17930],0); -ELEMENTS[23554] = Fluid3D([17553,17671,17909,17433],0); -ELEMENTS[23555] = Fluid3D([16831,16924,17113,16658],0); -ELEMENTS[23556] = Fluid3D([16924,17113,16658,16839],0); -ELEMENTS[23557] = Fluid3D([17539,17509,17170,17420],0); -ELEMENTS[23558] = Fluid3D([18050,17903,18166,17912],0); -ELEMENTS[23559] = Fluid3D([18050,17903,17912,17653],0); -ELEMENTS[23560] = Fluid3D([17903,18166,17912,17945],0); -ELEMENTS[23561] = Fluid3D([18166,18050,17912,18241],0); -ELEMENTS[23562] = Fluid3D([18050,17912,18241,17933],0); -ELEMENTS[23563] = Fluid3D([17912,18241,17933,18034],0); -ELEMENTS[23564] = Fluid3D([18050,17912,17933,17653],0); -ELEMENTS[23565] = Fluid3D([17912,18166,18241,18169],0); -ELEMENTS[23566] = Fluid3D([17912,18166,18169,17945],0); -ELEMENTS[23567] = Fluid3D([18241,17912,18169,18134],0); -ELEMENTS[23568] = Fluid3D([18166,18050,18241,18248],0); -ELEMENTS[23569] = Fluid3D([18050,18241,18248,18132],0); -ELEMENTS[23570] = Fluid3D([18166,18050,18248,18333],0); -ELEMENTS[23571] = Fluid3D([17912,18169,18134,18017],0); -ELEMENTS[23572] = Fluid3D([17912,18169,18017,17945],0); -ELEMENTS[23573] = Fluid3D([18134,17912,18017,17804],0); -ELEMENTS[23574] = Fluid3D([18017,18134,17804,17919],0); -ELEMENTS[23575] = Fluid3D([17804,18017,17919,17894],0); -ELEMENTS[23576] = Fluid3D([17912,18017,17804,17844],0); -ELEMENTS[23577] = Fluid3D([18017,17804,17844,17612],0); -ELEMENTS[23578] = Fluid3D([17804,17912,17844,17592],0); -ELEMENTS[23579] = Fluid3D([17844,17804,17592,17475],0); -ELEMENTS[23580] = Fluid3D([17912,18017,17844,17945],0); -ELEMENTS[23581] = Fluid3D([17592,17844,17475,17912],0); -ELEMENTS[23582] = Fluid3D([18017,17919,17894,18193],0); -ELEMENTS[23583] = Fluid3D([18134,17912,17804,18034],0); -ELEMENTS[23584] = Fluid3D([17804,18134,18034,18106],0); -ELEMENTS[23585] = Fluid3D([18169,18134,18017,18291],0); -ELEMENTS[23586] = Fluid3D([18017,17844,17945,17612],0); -ELEMENTS[23587] = Fluid3D([18241,17912,18134,18034],0); -ELEMENTS[23588] = Fluid3D([18169,18241,18134,18365],0); -ELEMENTS[23589] = Fluid3D([18166,18241,18169,18391],0); -ELEMENTS[23590] = Fluid3D([18169,18166,18391,18335],0); -ELEMENTS[23591] = Fluid3D([18241,18169,18391,18365],0); -ELEMENTS[23592] = Fluid3D([18391,18169,18335,18433],0); -ELEMENTS[23593] = Fluid3D([18166,18241,18391,18248],0); -ELEMENTS[23594] = Fluid3D([18169,18166,18335,18140],0); -ELEMENTS[23595] = Fluid3D([18169,18166,18140,17945],0); -ELEMENTS[23596] = Fluid3D([18335,18169,18140,18262],0); -ELEMENTS[23597] = Fluid3D([18166,18335,18140,18082],0); -ELEMENTS[23598] = Fluid3D([18169,18140,18262,18151],0); -ELEMENTS[23599] = Fluid3D([18262,18169,18151,18320],0); -ELEMENTS[23600] = Fluid3D([18151,18262,18320,18402],0); -ELEMENTS[23601] = Fluid3D([18140,18262,18151,18164],0); -ELEMENTS[23602] = Fluid3D([18140,18262,18164,18335],0); -ELEMENTS[23603] = Fluid3D([18164,18140,18335,18082],0); -ELEMENTS[23604] = Fluid3D([18262,18320,18402,18418],0); -ELEMENTS[23605] = Fluid3D([18262,18320,18418,18169],0); -ELEMENTS[23606] = Fluid3D([18320,18402,18418,18433],0); -ELEMENTS[23607] = Fluid3D([18418,18320,18433,18169],0); -ELEMENTS[23608] = Fluid3D([18320,18433,18169,18291],0); -ELEMENTS[23609] = Fluid3D([18320,18433,18291,18402],0); -ELEMENTS[23610] = Fluid3D([18335,18169,18262,18418],0); -ELEMENTS[23611] = Fluid3D([18166,18391,18335,18380],0); -ELEMENTS[23612] = Fluid3D([17830,17865,18107,18037],0); -ELEMENTS[23613] = Fluid3D([17509,17801,17688,17966],0); -ELEMENTS[23614] = Fluid3D([17995,17980,17716,17930],0); -ELEMENTS[23615] = Fluid3D([17980,17716,17930,17793],0); -ELEMENTS[23616] = Fluid3D([17995,17980,17930,18252],0); -ELEMENTS[23617] = Fluid3D([17980,17930,18252,18238],0); -ELEMENTS[23618] = Fluid3D([17980,17930,18238,17966],0); -ELEMENTS[23619] = Fluid3D([17259,17475,17212,16803],0); -ELEMENTS[23620] = Fluid3D([17586,17844,17945,17912],0); -ELEMENTS[23621] = Fluid3D([17170,17509,17243,17109],0); -ELEMENTS[23622] = Fluid3D([17509,17243,17109,17523],0); -ELEMENTS[23623] = Fluid3D([17509,17243,17523,17688],0); -ELEMENTS[23624] = Fluid3D([17523,17509,17688,17803],0); -ELEMENTS[23625] = Fluid3D([17243,17523,17688,17462],0); -ELEMENTS[23626] = Fluid3D([17523,17688,17462,17852],0); -ELEMENTS[23627] = Fluid3D([17243,17523,17462,17391],0); -ELEMENTS[23628] = Fluid3D([17523,17462,17391,17852],0); -ELEMENTS[23629] = Fluid3D([17109,17509,17523,17367],0); -ELEMENTS[23630] = Fluid3D([17509,17523,17367,17803],0); -ELEMENTS[23631] = Fluid3D([17109,17509,17367,17420],0); -ELEMENTS[23632] = Fluid3D([17243,17170,17109,16636],0); -ELEMENTS[23633] = Fluid3D([17170,17509,17109,17420],0); -ELEMENTS[23634] = Fluid3D([17604,17788,17865,17701],0); -ELEMENTS[23635] = Fluid3D([17612,17600,17894,17804],0); -ELEMENTS[23636] = Fluid3D([17548,17688,17800,17675],0); -ELEMENTS[23637] = Fluid3D([17995,17830,18107,18069],0); -ELEMENTS[23638] = Fluid3D([18107,17995,18069,18235],0); -ELEMENTS[23639] = Fluid3D([17995,18069,18235,18252],0); -ELEMENTS[23640] = Fluid3D([17995,17830,18069,17747],0); -ELEMENTS[23641] = Fluid3D([18107,17995,18235,18132],0); -ELEMENTS[23642] = Fluid3D([18069,18107,18235,18293],0); -ELEMENTS[23643] = Fluid3D([18107,18235,18293,18328],0); -ELEMENTS[23644] = Fluid3D([18069,18107,18293,18092],0); -ELEMENTS[23645] = Fluid3D([18293,18069,18092,18204],0); -ELEMENTS[23646] = Fluid3D([18293,18107,18328,18270],0); -ELEMENTS[23647] = Fluid3D([18293,18069,18204,18287],0); -ELEMENTS[23648] = Fluid3D([18293,18069,18287,18235],0); -ELEMENTS[23649] = Fluid3D([18293,18107,18270,18092],0); -ELEMENTS[23650] = Fluid3D([18328,18293,18270,18447],0); -ELEMENTS[23651] = Fluid3D([18328,18293,18447,18434],0); -ELEMENTS[23652] = Fluid3D([18293,18270,18447,18354],0); -ELEMENTS[23653] = Fluid3D([18293,18447,18434,18454],0); -ELEMENTS[23654] = Fluid3D([18293,18447,18454,18354],0); -ELEMENTS[23655] = Fluid3D([18293,18270,18354,18092],0); -ELEMENTS[23656] = Fluid3D([18328,18293,18434,18235],0); -ELEMENTS[23657] = Fluid3D([18092,18293,18204,18354],0); -ELEMENTS[23658] = Fluid3D([18069,18107,18092,17830],0); -ELEMENTS[23659] = Fluid3D([18270,18328,18447,18457],0); -ELEMENTS[23660] = Fluid3D([18204,18293,18287,18454],0); -ELEMENTS[23661] = Fluid3D([18069,18092,18204,17943],0); -ELEMENTS[23662] = Fluid3D([18092,18204,17943,18100],0); -ELEMENTS[23663] = Fluid3D([18069,18092,17943,17830],0); -ELEMENTS[23664] = Fluid3D([18204,18069,17943,18098],0); -ELEMENTS[23665] = Fluid3D([18204,17943,18100,18081],0); -ELEMENTS[23666] = Fluid3D([18204,17943,18081,18098],0); -ELEMENTS[23667] = Fluid3D([18069,17943,18098,17747],0); -ELEMENTS[23668] = Fluid3D([18100,18204,18081,18305],0); -ELEMENTS[23669] = Fluid3D([18100,18204,18305,18354],0); -ELEMENTS[23670] = Fluid3D([18204,18081,18305,18240],0); -ELEMENTS[23671] = Fluid3D([18305,18204,18240,18414],0); -ELEMENTS[23672] = Fluid3D([18204,18081,18240,18098],0); -ELEMENTS[23673] = Fluid3D([18081,18305,18240,18250],0); -ELEMENTS[23674] = Fluid3D([18305,18240,18250,18444],0); -ELEMENTS[23675] = Fluid3D([18250,18305,18444,18271],0); -ELEMENTS[23676] = Fluid3D([18444,18250,18271,18277],0); -ELEMENTS[23677] = Fluid3D([18250,18271,18277,18088],0); -ELEMENTS[23678] = Fluid3D([18250,18271,18088,18097],0); -ELEMENTS[23679] = Fluid3D([18250,18271,18097,18305],0); -ELEMENTS[23680] = Fluid3D([18305,18204,18414,18354],0); -ELEMENTS[23681] = Fluid3D([18081,18305,18250,18097],0); -ELEMENTS[23682] = Fluid3D([18305,18240,18444,18414],0); -ELEMENTS[23683] = Fluid3D([18092,18204,18100,18354],0); -ELEMENTS[23684] = Fluid3D([18204,18069,18098,18287],0); -ELEMENTS[23685] = Fluid3D([18081,18100,18305,18097],0); -ELEMENTS[23686] = Fluid3D([18240,18081,18250,18044],0); -ELEMENTS[23687] = Fluid3D([17943,18092,18100,17677],0); -ELEMENTS[23688] = Fluid3D([17943,18100,18081,17794],0); -ELEMENTS[23689] = Fluid3D([18081,17943,17794,17752],0); -ELEMENTS[23690] = Fluid3D([18100,18081,17794,18097],0); -ELEMENTS[23691] = Fluid3D([17943,18100,17794,17677],0); -ELEMENTS[23692] = Fluid3D([18204,18240,18414,18287],0); -ELEMENTS[23693] = Fluid3D([18107,18235,18328,18132],0); -ELEMENTS[23694] = Fluid3D([18107,18328,18270,18037],0); -ELEMENTS[23695] = Fluid3D([18434,18293,18454,18287],0); -ELEMENTS[23696] = Fluid3D([18447,18328,18434,18506],0); -ELEMENTS[23697] = Fluid3D([18447,18434,18454,18552],0); -ELEMENTS[23698] = Fluid3D([18447,18434,18552,18506],0); -ELEMENTS[23699] = Fluid3D([18454,18447,18552,18604],0); -ELEMENTS[23700] = Fluid3D([18434,18454,18552,18525],0); -ELEMENTS[23701] = Fluid3D([18434,18454,18525,18287],0); -ELEMENTS[23702] = Fluid3D([18552,18434,18525,18551],0); -ELEMENTS[23703] = Fluid3D([18552,18434,18551,18591],0); -ELEMENTS[23704] = Fluid3D([18525,18552,18551,18617],0); -ELEMENTS[23705] = Fluid3D([18552,18551,18617,18591],0); -ELEMENTS[23706] = Fluid3D([18454,18552,18525,18571],0); -ELEMENTS[23707] = Fluid3D([18454,18552,18571,18604],0); -ELEMENTS[23708] = Fluid3D([18525,18454,18571,18414],0); -ELEMENTS[23709] = Fluid3D([18454,18571,18414,18504],0); -ELEMENTS[23710] = Fluid3D([18414,18454,18504,18354],0); -ELEMENTS[23711] = Fluid3D([18454,18571,18504,18604],0); -ELEMENTS[23712] = Fluid3D([18552,18525,18571,18617],0); -ELEMENTS[23713] = Fluid3D([18454,18504,18354,18447],0); -ELEMENTS[23714] = Fluid3D([18414,18454,18354,18204],0); -ELEMENTS[23715] = Fluid3D([18414,18454,18204,18287],0); -ELEMENTS[23716] = Fluid3D([18551,18525,18617,18584],0); -ELEMENTS[23717] = Fluid3D([18617,18551,18584,18644],0); -ELEMENTS[23718] = Fluid3D([18525,18617,18584,18603],0); -ELEMENTS[23719] = Fluid3D([18551,18525,18584,18464],0); -ELEMENTS[23720] = Fluid3D([18617,18584,18603,18651],0); -ELEMENTS[23721] = Fluid3D([18525,18584,18464,18510],0); -ELEMENTS[23722] = Fluid3D([18584,18603,18651,18615],0); -ELEMENTS[23723] = Fluid3D([18603,18651,18615,18656],0); -ELEMENTS[23724] = Fluid3D([18603,18651,18656,18653],0); -ELEMENTS[23725] = Fluid3D([18603,18651,18653,18617],0); -ELEMENTS[23726] = Fluid3D([18525,18584,18510,18603],0); -ELEMENTS[23727] = Fluid3D([18584,18603,18615,18510],0); -ELEMENTS[23728] = Fluid3D([18617,18584,18651,18644],0); -ELEMENTS[23729] = Fluid3D([18651,18615,18656,18671],0); -ELEMENTS[23730] = Fluid3D([18615,18656,18671,18648],0); -ELEMENTS[23731] = Fluid3D([18656,18671,18648,18692],0); -ELEMENTS[23732] = Fluid3D([18651,18615,18671,18643],0); -ELEMENTS[23733] = Fluid3D([18615,18671,18643,18638],0); -ELEMENTS[23734] = Fluid3D([18643,18615,18638,18520],0); -ELEMENTS[23735] = Fluid3D([18656,18651,18671,18689],0); -ELEMENTS[23736] = Fluid3D([18615,18671,18638,18648],0); -ELEMENTS[23737] = Fluid3D([18651,18615,18643,18584],0); -ELEMENTS[23738] = Fluid3D([18671,18651,18643,18677],0); -ELEMENTS[23739] = Fluid3D([18615,18656,18648,18599],0); -ELEMENTS[23740] = Fluid3D([18615,18656,18599,18603],0); -ELEMENTS[23741] = Fluid3D([18656,18648,18599,18655],0); -ELEMENTS[23742] = Fluid3D([18599,18656,18655,18625],0); -ELEMENTS[23743] = Fluid3D([18656,18648,18655,18674],0); -ELEMENTS[23744] = Fluid3D([18648,18655,18674,18639],0); -ELEMENTS[23745] = Fluid3D([18655,18674,18639,18661],0); -ELEMENTS[23746] = Fluid3D([18655,18674,18661,18684],0); -ELEMENTS[23747] = Fluid3D([18639,18655,18661,18606],0); -ELEMENTS[23748] = Fluid3D([18655,18661,18606,18625],0); -ELEMENTS[23749] = Fluid3D([18655,18661,18625,18684],0); -ELEMENTS[23750] = Fluid3D([18606,18655,18625,18599],0); -ELEMENTS[23751] = Fluid3D([18655,18674,18684,18656],0); -ELEMENTS[23752] = Fluid3D([18606,18655,18599,18639],0); -ELEMENTS[23753] = Fluid3D([18625,18606,18599,18529],0); -ELEMENTS[23754] = Fluid3D([18625,18606,18529,18572],0); -ELEMENTS[23755] = Fluid3D([18625,18606,18572,18661],0); -ELEMENTS[23756] = Fluid3D([18606,18529,18572,18547],0); -ELEMENTS[23757] = Fluid3D([18606,18529,18547,18474],0); -ELEMENTS[23758] = Fluid3D([18606,18529,18474,18599],0); -ELEMENTS[23759] = Fluid3D([18529,18547,18474,18405],0); -ELEMENTS[23760] = Fluid3D([18529,18625,18572,18596],0); -ELEMENTS[23761] = Fluid3D([18625,18572,18596,18650],0); -ELEMENTS[23762] = Fluid3D([18625,18572,18650,18645],0); -ELEMENTS[23763] = Fluid3D([18529,18625,18596,18603],0); -ELEMENTS[23764] = Fluid3D([18572,18596,18650,18588],0); -ELEMENTS[23765] = Fluid3D([18572,18606,18547,18619],0); -ELEMENTS[23766] = Fluid3D([18547,18606,18474,18577],0); -ELEMENTS[23767] = Fluid3D([18596,18625,18650,18653],0); -ELEMENTS[23768] = Fluid3D([18599,18625,18529,18603],0); -ELEMENTS[23769] = Fluid3D([18572,18596,18588,18444],0); -ELEMENTS[23770] = Fluid3D([18529,18572,18547,18463],0); -ELEMENTS[23771] = Fluid3D([18648,18615,18599,18567],0); -ELEMENTS[23772] = Fluid3D([18648,18615,18567,18638],0); -ELEMENTS[23773] = Fluid3D([18529,18572,18463,18444],0); -ELEMENTS[23774] = Fluid3D([18529,18547,18405,18463],0); -ELEMENTS[23775] = Fluid3D([18599,18656,18625,18603],0); -ELEMENTS[23776] = Fluid3D([18572,18547,18463,18507],0); -ELEMENTS[23777] = Fluid3D([18572,18547,18507,18594],0); -ELEMENTS[23778] = Fluid3D([18547,18463,18507,18405],0); -ELEMENTS[23779] = Fluid3D([18463,18572,18507,18537],0); -ELEMENTS[23780] = Fluid3D([18572,18507,18537,18626],0); -ELEMENTS[23781] = Fluid3D([18507,18463,18537,18427],0); -ELEMENTS[23782] = Fluid3D([18537,18507,18427,18459],0); -ELEMENTS[23783] = Fluid3D([18507,18427,18459,18460],0); -ELEMENTS[23784] = Fluid3D([18427,18537,18459,18487],0); -ELEMENTS[23785] = Fluid3D([18459,18427,18487,18271],0); -ELEMENTS[23786] = Fluid3D([18459,18427,18271,18277],0); -ELEMENTS[23787] = Fluid3D([18459,18427,18277,18460],0); -ELEMENTS[23788] = Fluid3D([18537,18507,18459,18564],0); -ELEMENTS[23789] = Fluid3D([18507,18427,18460,18280],0); -ELEMENTS[23790] = Fluid3D([18427,18487,18271,18444],0); -ELEMENTS[23791] = Fluid3D([18427,18537,18487,18444],0); -ELEMENTS[23792] = Fluid3D([18507,18463,18427,18280],0); -ELEMENTS[23793] = Fluid3D([18537,18459,18487,18534],0); -ELEMENTS[23794] = Fluid3D([18459,18507,18460,18564],0); -ELEMENTS[23795] = Fluid3D([18427,18271,18277,18444],0); -ELEMENTS[23796] = Fluid3D([18537,18459,18534,18564],0); -ELEMENTS[23797] = Fluid3D([18487,18459,18271,18383],0); -ELEMENTS[23798] = Fluid3D([18487,18459,18383,18534],0); -ELEMENTS[23799] = Fluid3D([18271,18487,18383,18319],0); -ELEMENTS[23800] = Fluid3D([18487,18383,18319,18489],0); -ELEMENTS[23801] = Fluid3D([18487,18383,18489,18534],0); -ELEMENTS[23802] = Fluid3D([18271,18487,18319,18444],0); -ELEMENTS[23803] = Fluid3D([18463,18537,18427,18444],0); -ELEMENTS[23804] = Fluid3D([18427,18463,18444,18349],0); -ELEMENTS[23805] = Fluid3D([18463,18444,18349,18405],0); -ELEMENTS[23806] = Fluid3D([18349,18463,18405,18280],0); -ELEMENTS[23807] = Fluid3D([18405,18349,18280,18200],0); -ELEMENTS[23808] = Fluid3D([18405,18349,18200,18240],0); -ELEMENTS[23809] = Fluid3D([18427,18463,18349,18280],0); -ELEMENTS[23810] = Fluid3D([18280,18405,18200,18313],0); -ELEMENTS[23811] = Fluid3D([18280,18405,18313,18474],0); -ELEMENTS[23812] = Fluid3D([18349,18280,18200,18277],0); -ELEMENTS[23813] = Fluid3D([18349,18200,18240,18250],0); -ELEMENTS[23814] = Fluid3D([18349,18280,18277,18427],0); -ELEMENTS[23815] = Fluid3D([18405,18200,18313,18276],0); -ELEMENTS[23816] = Fluid3D([18427,18277,18460,18280],0); -ELEMENTS[23817] = Fluid3D([18405,18200,18276,18240],0); -ELEMENTS[23818] = Fluid3D([18319,18487,18489,18493],0); -ELEMENTS[23819] = Fluid3D([18405,18349,18240,18444],0); -ELEMENTS[23820] = Fluid3D([18349,18240,18444,18250],0); -ELEMENTS[23821] = Fluid3D([18319,18487,18493,18444],0); -ELEMENTS[23822] = Fluid3D([18313,18405,18276,18474],0); -ELEMENTS[23823] = Fluid3D([18507,18537,18626,18564],0); -ELEMENTS[23824] = Fluid3D([18383,18319,18489,18329],0); -ELEMENTS[23825] = Fluid3D([18319,18489,18329,18420],0); -ELEMENTS[23826] = Fluid3D([18329,18319,18420,18232],0); -ELEMENTS[23827] = Fluid3D([18329,18319,18232,18097],0); -ELEMENTS[23828] = Fluid3D([18383,18319,18329,18173],0); -ELEMENTS[23829] = Fluid3D([18319,18329,18173,18097],0); -ELEMENTS[23830] = Fluid3D([18173,18319,18097,18383],0); -ELEMENTS[23831] = Fluid3D([18319,18420,18232,18357],0); -ELEMENTS[23832] = Fluid3D([18420,18329,18232,18206],0); -ELEMENTS[23833] = Fluid3D([18232,18319,18357,18097],0); -ELEMENTS[23834] = Fluid3D([18319,18420,18357,18493],0); -ELEMENTS[23835] = Fluid3D([18420,18357,18493,18491],0); -ELEMENTS[23836] = Fluid3D([18319,18420,18493,18489],0); -ELEMENTS[23837] = Fluid3D([18493,18420,18491,18555],0); -ELEMENTS[23838] = Fluid3D([18493,18420,18555,18489],0); -ELEMENTS[23839] = Fluid3D([18357,18493,18491,18495],0); -ELEMENTS[23840] = Fluid3D([18357,18493,18495,18444],0); -ELEMENTS[23841] = Fluid3D([18357,18319,18493,18444],0); -ELEMENTS[23842] = Fluid3D([18491,18493,18555,18616],0); -ELEMENTS[23843] = Fluid3D([18493,18491,18495,18616],0); -ELEMENTS[23844] = Fluid3D([18459,18383,18534,18347],0); -ELEMENTS[23845] = Fluid3D([18200,18280,18313,18067],0); -ELEMENTS[23846] = Fluid3D([18487,18489,18493,18574],0); -ELEMENTS[23847] = Fluid3D([18487,18489,18574,18534],0); -ELEMENTS[23848] = Fluid3D([18444,18349,18250,18277],0); -ELEMENTS[23849] = Fluid3D([18487,18537,18534,18574],0); -ELEMENTS[23850] = Fluid3D([18277,18349,18427,18444],0); -ELEMENTS[23851] = Fluid3D([18420,18491,18555,18541],0); -ELEMENTS[23852] = Fluid3D([18491,18555,18541,18616],0); -ELEMENTS[23853] = Fluid3D([18493,18487,18574,18588],0); -ELEMENTS[23854] = Fluid3D([18383,18271,18319,18097],0); -ELEMENTS[23855] = Fluid3D([18420,18357,18491,18334],0); -ELEMENTS[23856] = Fluid3D([18491,18420,18334,18541],0); -ELEMENTS[23857] = Fluid3D([18200,18313,18276,18067],0); -ELEMENTS[23858] = Fluid3D([18491,18357,18495,18393],0); -ELEMENTS[23859] = Fluid3D([18357,18495,18393,18305],0); -ELEMENTS[23860] = Fluid3D([18489,18493,18574,18555],0); -ELEMENTS[23861] = Fluid3D([18489,18329,18420,18452],0); -ELEMENTS[23862] = Fluid3D([18329,18420,18452,18206],0); -ELEMENTS[23863] = Fluid3D([18357,18491,18334,18393],0); -ELEMENTS[23864] = Fluid3D([18495,18491,18393,18570],0); -ELEMENTS[23865] = Fluid3D([18420,18357,18334,18232],0); -ELEMENTS[23866] = Fluid3D([18357,18334,18232,18155],0); -ELEMENTS[23867] = Fluid3D([18232,18357,18155,18097],0); -ELEMENTS[23868] = Fluid3D([18334,18420,18232,18307],0); -ELEMENTS[23869] = Fluid3D([18334,18420,18307,18517],0); -ELEMENTS[23870] = Fluid3D([18334,18232,18155,18087],0); -ELEMENTS[23871] = Fluid3D([18334,18232,18087,18307],0); -ELEMENTS[23872] = Fluid3D([18383,18534,18347,18470],0); -ELEMENTS[23873] = Fluid3D([18347,18383,18470,18329],0); -ELEMENTS[23874] = Fluid3D([18383,18534,18470,18489],0); -ELEMENTS[23875] = Fluid3D([18470,18383,18489,18329],0); -ELEMENTS[23876] = Fluid3D([18489,18470,18329,18452],0); -ELEMENTS[23877] = Fluid3D([18489,18470,18452,18565],0); -ELEMENTS[23878] = Fluid3D([18489,18470,18565,18534],0); -ELEMENTS[23879] = Fluid3D([18452,18489,18565,18555],0); -ELEMENTS[23880] = Fluid3D([18357,18334,18155,18393],0); -ELEMENTS[23881] = Fluid3D([18155,18334,18087,18185],0); -ELEMENTS[23882] = Fluid3D([18334,18087,18185,18290],0); -ELEMENTS[23883] = Fluid3D([18087,18185,18290,18072],0); -ELEMENTS[23884] = Fluid3D([18155,18334,18185,18393],0); -ELEMENTS[23885] = Fluid3D([18087,18155,18185,17939],0); -ELEMENTS[23886] = Fluid3D([18087,18155,17939,17832],0); -ELEMENTS[23887] = Fluid3D([18185,18087,17939,18001],0); -ELEMENTS[23888] = Fluid3D([18087,17939,18001,17740],0); -ELEMENTS[23889] = Fluid3D([18155,18185,17939,18112],0); -ELEMENTS[23890] = Fluid3D([18185,17939,18112,18005],0); -ELEMENTS[23891] = Fluid3D([18185,17939,18005,18001],0); -ELEMENTS[23892] = Fluid3D([18155,18185,18112,18393],0); -ELEMENTS[23893] = Fluid3D([18185,18087,18001,18072],0); -ELEMENTS[23894] = Fluid3D([18087,18001,18072,17740],0); -ELEMENTS[23895] = Fluid3D([18001,18072,17740,17808],0); -ELEMENTS[23896] = Fluid3D([18001,18072,17808,18104],0); -ELEMENTS[23897] = Fluid3D([18001,18072,18104,18304],0); -ELEMENTS[23898] = Fluid3D([17808,18001,18104,17902],0); -ELEMENTS[23899] = Fluid3D([17808,18001,17902,17700],0); -ELEMENTS[23900] = Fluid3D([17808,18001,17700,17740],0); -ELEMENTS[23901] = Fluid3D([18001,17700,17740,17939],0); -ELEMENTS[23902] = Fluid3D([17700,17808,17740,17627],0); -ELEMENTS[23903] = Fluid3D([17808,17740,17627,18072],0); -ELEMENTS[23904] = Fluid3D([18001,18104,17902,18005],0); -ELEMENTS[23905] = Fluid3D([17902,18001,18005,17700],0); -ELEMENTS[23906] = Fluid3D([18072,17808,18104,17983],0); -ELEMENTS[23907] = Fluid3D([18072,17808,17983,17627],0); -ELEMENTS[23908] = Fluid3D([18104,18072,17983,18242],0); -ELEMENTS[23909] = Fluid3D([18072,17983,18242,18165],0); -ELEMENTS[23910] = Fluid3D([17902,17808,17700,17634],0); -ELEMENTS[23911] = Fluid3D([18104,17808,17902,17885],0); -ELEMENTS[23912] = Fluid3D([17808,17902,17885,17634],0); -ELEMENTS[23913] = Fluid3D([17902,18104,17885,18181],0); -ELEMENTS[23914] = Fluid3D([18104,17808,17885,18120],0); -ELEMENTS[23915] = Fluid3D([17885,18104,18120,18181],0); -ELEMENTS[23916] = Fluid3D([18104,18120,18181,18304],0); -ELEMENTS[23917] = Fluid3D([18104,18120,18304,18242],0); -ELEMENTS[23918] = Fluid3D([18181,18104,18304,18189],0); -ELEMENTS[23919] = Fluid3D([18104,18304,18189,18001],0); -ELEMENTS[23920] = Fluid3D([18189,18104,18001,18005],0); -ELEMENTS[23921] = Fluid3D([18181,18104,18189,18005],0); -ELEMENTS[23922] = Fluid3D([18001,18189,18005,18185],0); -ELEMENTS[23923] = Fluid3D([18001,18189,18185,18304],0); -ELEMENTS[23924] = Fluid3D([18189,18005,18185,18267],0); -ELEMENTS[23925] = Fluid3D([18185,18189,18267,18353],0); -ELEMENTS[23926] = Fluid3D([18189,18267,18353,18181],0); -ELEMENTS[23927] = Fluid3D([18185,18189,18353,18304],0); -ELEMENTS[23928] = Fluid3D([18189,18005,18267,18181],0); -ELEMENTS[23929] = Fluid3D([18189,18353,18304,18181],0); -ELEMENTS[23930] = Fluid3D([18267,18185,18353,18483],0); -ELEMENTS[23931] = Fluid3D([18005,18185,18267,18112],0); -ELEMENTS[23932] = Fluid3D([18185,18267,18112,18393],0); -ELEMENTS[23933] = Fluid3D([18005,17902,17700,17751],0); -ELEMENTS[23934] = Fluid3D([18005,17902,17751,18181],0); -ELEMENTS[23935] = Fluid3D([18334,18087,18290,18307],0); -ELEMENTS[23936] = Fluid3D([18648,18599,18655,18639],0); -ELEMENTS[23937] = Fluid3D([18551,18525,18464,18434],0); -ELEMENTS[23938] = Fluid3D([18185,18334,18290,18439],0); -ELEMENTS[23939] = Fluid3D([18547,18474,18405,18280],0); -ELEMENTS[23940] = Fluid3D([18405,18547,18280,18507],0); -ELEMENTS[23941] = Fluid3D([18584,18464,18510,18520],0); -ELEMENTS[23942] = Fluid3D([18650,18572,18588,18645],0); -ELEMENTS[23943] = Fluid3D([18656,18655,18625,18684],0); -ELEMENTS[23944] = Fluid3D([18474,18529,18405,18480],0); -ELEMENTS[23945] = Fluid3D([18474,18529,18480,18599],0); -ELEMENTS[23946] = Fluid3D([18529,18405,18480,18431],0); -ELEMENTS[23947] = Fluid3D([18529,18405,18431,18444],0); -ELEMENTS[23948] = Fluid3D([18480,18529,18431,18603],0); -ELEMENTS[23949] = Fluid3D([18405,18474,18480,18276],0); -ELEMENTS[23950] = Fluid3D([18480,18405,18276,18431],0); -ELEMENTS[23951] = Fluid3D([17939,18112,18005,17677],0); -ELEMENTS[23952] = Fluid3D([18671,18643,18638,18675],0); -ELEMENTS[23953] = Fluid3D([18638,18671,18675,18679],0); -ELEMENTS[23954] = Fluid3D([18671,18675,18679,18691],0); -ELEMENTS[23955] = Fluid3D([18671,18643,18675,18677],0); -ELEMENTS[23956] = Fluid3D([18679,18671,18691,18692],0); -ELEMENTS[23957] = Fluid3D([18671,18675,18691,18693],0); -ELEMENTS[23958] = Fluid3D([18675,18638,18679,18659],0); -ELEMENTS[23959] = Fluid3D([18638,18671,18679,18648],0); -ELEMENTS[23960] = Fluid3D([18643,18638,18675,18628],0); -ELEMENTS[23961] = Fluid3D([18638,18675,18628,18659],0); -ELEMENTS[23962] = Fluid3D([18675,18628,18659,18669],0); -ELEMENTS[23963] = Fluid3D([18675,18628,18669,18643],0); -ELEMENTS[23964] = Fluid3D([18628,18659,18669,18613],0); -ELEMENTS[23965] = Fluid3D([18669,18628,18613,18629],0); -ELEMENTS[23966] = Fluid3D([18628,18659,18613,18593],0); -ELEMENTS[23967] = Fluid3D([18628,18638,18659,18593],0); -ELEMENTS[23968] = Fluid3D([18628,18613,18629,18518],0); -ELEMENTS[23969] = Fluid3D([18643,18638,18628,18520],0); -ELEMENTS[23970] = Fluid3D([18675,18679,18691,18688],0); -ELEMENTS[23971] = Fluid3D([18691,18675,18688,18695],0); -ELEMENTS[23972] = Fluid3D([18675,18679,18688,18659],0); -ELEMENTS[23973] = Fluid3D([18688,18675,18659,18669],0); -ELEMENTS[23974] = Fluid3D([18688,18675,18669,18695],0); -ELEMENTS[23975] = Fluid3D([18615,18599,18567,18510],0); -ELEMENTS[23976] = Fluid3D([18525,18617,18603,18571],0); -ELEMENTS[23977] = Fluid3D([18464,18525,18510,18287],0); -ELEMENTS[23978] = Fluid3D([18584,18551,18464,18578],0); -ELEMENTS[23979] = Fluid3D([18584,18551,18578,18644],0); -ELEMENTS[23980] = Fluid3D([18464,18584,18578,18520],0); -ELEMENTS[23981] = Fluid3D([18551,18464,18578,18472],0); -ELEMENTS[23982] = Fluid3D([18551,18464,18472,18434],0); -ELEMENTS[23983] = Fluid3D([18578,18551,18472,18583],0); -ELEMENTS[23984] = Fluid3D([18472,18551,18434,18591],0); -ELEMENTS[23985] = Fluid3D([18464,18578,18472,18429],0); -ELEMENTS[23986] = Fluid3D([18472,18464,18429,18252],0); -ELEMENTS[23987] = Fluid3D([18464,18578,18429,18520],0); -ELEMENTS[23988] = Fluid3D([18464,18429,18252,18363],0); -ELEMENTS[23989] = Fluid3D([18464,18429,18363,18520],0); -ELEMENTS[23990] = Fluid3D([18651,18656,18653,18689],0); -ELEMENTS[23991] = Fluid3D([18572,18529,18596,18444],0); -ELEMENTS[23992] = Fluid3D([18596,18650,18588,18620],0); -ELEMENTS[23993] = Fluid3D([18650,18588,18620,18652],0); -ELEMENTS[23994] = Fluid3D([18596,18650,18620,18640],0); -ELEMENTS[23995] = Fluid3D([18588,18620,18652,18574],0); -ELEMENTS[23996] = Fluid3D([18650,18620,18640,18673],0); -ELEMENTS[23997] = Fluid3D([18588,18596,18620,18528],0); -ELEMENTS[23998] = Fluid3D([18620,18588,18528,18493],0); -ELEMENTS[23999] = Fluid3D([18588,18596,18528,18444],0); -ELEMENTS[24000] = Fluid3D([18596,18620,18528,18571],0); -ELEMENTS[24001] = Fluid3D([18650,18588,18652,18672],0); -ELEMENTS[24002] = Fluid3D([18652,18650,18672,18690],0); -ELEMENTS[24003] = Fluid3D([18620,18650,18652,18673],0); -ELEMENTS[24004] = Fluid3D([18596,18650,18640,18653],0); -ELEMENTS[24005] = Fluid3D([18620,18596,18640,18571],0); -ELEMENTS[24006] = Fluid3D([18656,18603,18653,18625],0); -ELEMENTS[24007] = Fluid3D([17939,18155,18112,18100],0); -ELEMENTS[24008] = Fluid3D([18155,18112,18100,18393],0); -ELEMENTS[24009] = Fluid3D([17581,17259,17345,17203],0); -ELEMENTS[24010] = Fluid3D([17581,17259,17203,17245],0); -ELEMENTS[24011] = Fluid3D([17259,17345,17203,16930],0); -ELEMENTS[24012] = Fluid3D([17259,17345,16930,17212],0); -ELEMENTS[24013] = Fluid3D([17203,17259,16930,16920],0); -ELEMENTS[24014] = Fluid3D([17203,17259,16920,17245],0); -ELEMENTS[24015] = Fluid3D([16920,17203,17245,16791],0); -ELEMENTS[24016] = Fluid3D([17259,16930,16920,16803],0); -ELEMENTS[24017] = Fluid3D([17345,17581,17203,17531],0); -ELEMENTS[24018] = Fluid3D([17581,17203,17531,17245],0); -ELEMENTS[24019] = Fluid3D([17203,17531,17245,17104],0); -ELEMENTS[24020] = Fluid3D([17245,17203,17104,16791],0); -ELEMENTS[24021] = Fluid3D([17203,17531,17104,17326],0); -ELEMENTS[24022] = Fluid3D([17203,17531,17326,17345],0); -ELEMENTS[24023] = Fluid3D([17326,17203,17345,16930],0); -ELEMENTS[24024] = Fluid3D([17104,17203,17326,16838],0); -ELEMENTS[24025] = Fluid3D([17203,17326,16838,16930],0); -ELEMENTS[24026] = Fluid3D([16838,17203,16930,16578],0); -ELEMENTS[24027] = Fluid3D([16930,16838,16578,16616],0); -ELEMENTS[24028] = Fluid3D([16930,16838,16616,16984],0); -ELEMENTS[24029] = Fluid3D([16616,16930,16984,16728],0); -ELEMENTS[24030] = Fluid3D([16838,16616,16984,16263],0); -ELEMENTS[24031] = Fluid3D([16930,16838,16984,17326],0); -ELEMENTS[24032] = Fluid3D([16616,16930,16728,16463],0); -ELEMENTS[24033] = Fluid3D([16838,16578,16616,16487],0); -ELEMENTS[24034] = Fluid3D([16616,16838,16487,16263],0); -ELEMENTS[24035] = Fluid3D([16578,16930,16616,16463],0); -ELEMENTS[24036] = Fluid3D([16838,16578,16487,16791],0); -ELEMENTS[24037] = Fluid3D([16838,16984,17326,16968],0); -ELEMENTS[24038] = Fluid3D([16984,17326,16968,17243],0); -ELEMENTS[24039] = Fluid3D([16838,16984,16968,16263],0); -ELEMENTS[24040] = Fluid3D([17104,17203,16838,16791],0); -ELEMENTS[24041] = Fluid3D([17326,16838,16968,17104],0); -ELEMENTS[24042] = Fluid3D([16930,17203,16920,16578],0); -ELEMENTS[24043] = Fluid3D([16920,16930,16578,16803],0); -ELEMENTS[24044] = Fluid3D([17788,18050,18132,17933],0); -ELEMENTS[24045] = Fluid3D([17612,17308,17321,17390],0); -ELEMENTS[24046] = Fluid3D([18060,18050,18166,18333],0); -ELEMENTS[24047] = Fluid3D([18420,18232,18307,18206],0); -ELEMENTS[24048] = Fluid3D([17548,17170,17243,16984],0); -ELEMENTS[24049] = Fluid3D([17548,17170,16984,17345],0); -ELEMENTS[24050] = Fluid3D([17170,16984,17345,16728],0); -ELEMENTS[24051] = Fluid3D([17355,17604,17443,17210],0); -ELEMENTS[24052] = Fluid3D([17355,17604,17210,17420],0); -ELEMENTS[24053] = Fluid3D([17604,17443,17210,17446],0); -ELEMENTS[24054] = Fluid3D([17210,17604,17446,17364],0); -ELEMENTS[24055] = Fluid3D([17210,17604,17364,17420],0); -ELEMENTS[24056] = Fluid3D([17604,17443,17446,17830],0); -ELEMENTS[24057] = Fluid3D([17446,17210,17364,16873],0); -ELEMENTS[24058] = Fluid3D([17443,17355,17210,16924],0); -ELEMENTS[24059] = Fluid3D([17604,17446,17364,17703],0); -ELEMENTS[24060] = Fluid3D([17604,17446,17703,17830],0); -ELEMENTS[24061] = Fluid3D([17364,17604,17703,17701],0); -ELEMENTS[24062] = Fluid3D([17703,17364,17701,17552],0); -ELEMENTS[24063] = Fluid3D([17701,17703,17552,17833],0); -ELEMENTS[24064] = Fluid3D([17703,17552,17833,17710],0); -ELEMENTS[24065] = Fluid3D([17552,17833,17710,17595],0); -ELEMENTS[24066] = Fluid3D([17552,17701,17833,17637],0); -ELEMENTS[24067] = Fluid3D([17833,17552,17637,17595],0); -ELEMENTS[24068] = Fluid3D([17703,17552,17710,17446],0); -ELEMENTS[24069] = Fluid3D([17701,17703,17833,17865],0); -ELEMENTS[24070] = Fluid3D([17701,17703,17865,17604],0); -ELEMENTS[24071] = Fluid3D([17703,17865,17604,17830],0); -ELEMENTS[24072] = Fluid3D([17703,17865,17830,18037],0); -ELEMENTS[24073] = Fluid3D([17703,17865,18037,17833],0); -ELEMENTS[24074] = Fluid3D([17833,17703,17710,18037],0); -ELEMENTS[24075] = Fluid3D([17710,17833,18037,17940],0); -ELEMENTS[24076] = Fluid3D([17703,17364,17552,17446],0); -ELEMENTS[24077] = Fluid3D([17443,17210,17446,17101],0); -ELEMENTS[24078] = Fluid3D([17446,17443,17101,17473],0); -ELEMENTS[24079] = Fluid3D([17443,17210,17101,16924],0); -ELEMENTS[24080] = Fluid3D([17101,17446,17473,16957],0); -ELEMENTS[24081] = Fluid3D([17473,17101,16957,16839],0); -ELEMENTS[24082] = Fluid3D([17210,17446,17101,16873],0); -ELEMENTS[24083] = Fluid3D([17446,17443,17473,17830],0); -ELEMENTS[24084] = Fluid3D([17443,17101,17473,17239],0); -ELEMENTS[24085] = Fluid3D([17443,17101,17239,16924],0); -ELEMENTS[24086] = Fluid3D([17101,17473,17239,16839],0); -ELEMENTS[24087] = Fluid3D([17473,17443,17239,17587],0); -ELEMENTS[24088] = Fluid3D([17473,17443,17587,17830],0); -ELEMENTS[24089] = Fluid3D([17239,17473,17587,17540],0); -ELEMENTS[24090] = Fluid3D([17443,17239,17587,17432],0); -ELEMENTS[24091] = Fluid3D([17443,17239,17432,17113],0); -ELEMENTS[24092] = Fluid3D([17239,17432,17113,17532],0); -ELEMENTS[24093] = Fluid3D([17432,17113,17532,17236],0); -ELEMENTS[24094] = Fluid3D([17587,17443,17432,17747],0); -ELEMENTS[24095] = Fluid3D([17239,17587,17432,17532],0); -ELEMENTS[24096] = Fluid3D([17364,17701,17552,17305],0); -ELEMENTS[24097] = Fluid3D([17552,17364,17305,17103],0); -ELEMENTS[24098] = Fluid3D([17305,17552,17103,17595],0); -ELEMENTS[24099] = Fluid3D([17701,17552,17305,17637],0); -ELEMENTS[24100] = Fluid3D([17552,17305,17637,17595],0); -ELEMENTS[24101] = Fluid3D([17600,17785,17919,17649],0); -ELEMENTS[24102] = Fluid3D([17600,17785,17649,17372],0); -ELEMENTS[24103] = Fluid3D([17919,17600,17649,17451],0); -ELEMENTS[24104] = Fluid3D([17785,17919,17649,18002],0); -ELEMENTS[24105] = Fluid3D([18270,18447,18354,18457],0); -ELEMENTS[24106] = Fluid3D([18606,18547,18619,18577],0); -ELEMENTS[24107] = Fluid3D([18232,18155,18087,17832],0); -ELEMENTS[24108] = Fluid3D([17725,17801,17903,17922],0); -ELEMENTS[24109] = Fluid3D([17725,17801,17922,17776],0); -ELEMENTS[24110] = Fluid3D([17922,17725,17776,17878],0); -ELEMENTS[24111] = Fluid3D([17922,17725,17878,17945],0); -ELEMENTS[24112] = Fluid3D([17903,17725,17922,17945],0); -ELEMENTS[24113] = Fluid3D([17776,17922,17878,18083],0); -ELEMENTS[24114] = Fluid3D([17922,17878,18083,18164],0); -ELEMENTS[24115] = Fluid3D([17776,17922,18083,17801],0); -ELEMENTS[24116] = Fluid3D([18083,17922,18164,18082],0); -ELEMENTS[24117] = Fluid3D([18083,17922,18082,18022],0); -ELEMENTS[24118] = Fluid3D([17922,18082,18022,17801],0); -ELEMENTS[24119] = Fluid3D([18082,18083,18022,18260],0); -ELEMENTS[24120] = Fluid3D([18082,18022,17801,17903],0); -ELEMENTS[24121] = Fluid3D([18083,17922,18022,17801],0); -ELEMENTS[24122] = Fluid3D([17922,18082,17801,17903],0); -ELEMENTS[24123] = Fluid3D([17922,18082,17903,17945],0); -ELEMENTS[24124] = Fluid3D([17586,17475,17844,17912],0); -ELEMENTS[24125] = Fluid3D([18060,18166,18082,18380],0); -ELEMENTS[24126] = Fluid3D([18599,18648,18567,18600],0); -ELEMENTS[24127] = Fluid3D([18567,18599,18600,18474],0); -ELEMENTS[24128] = Fluid3D([18599,18648,18600,18639],0); -ELEMENTS[24129] = Fluid3D([18648,18567,18600,18627],0); -ELEMENTS[24130] = Fluid3D([18600,18648,18627,18663],0); -ELEMENTS[24131] = Fluid3D([18648,18567,18627,18638],0); -ELEMENTS[24132] = Fluid3D([18567,18600,18627,18561],0); -ELEMENTS[24133] = Fluid3D([18627,18567,18561,18638],0); -ELEMENTS[24134] = Fluid3D([18567,18600,18561,18513],0); -ELEMENTS[24135] = Fluid3D([18561,18567,18513,18411],0); -ELEMENTS[24136] = Fluid3D([18567,18600,18513,18474],0); -ELEMENTS[24137] = Fluid3D([18600,18513,18474,18524],0); -ELEMENTS[24138] = Fluid3D([18600,18627,18561,18602],0); -ELEMENTS[24139] = Fluid3D([18627,18561,18602,18631],0); -ELEMENTS[24140] = Fluid3D([18602,18627,18631,18663],0); -ELEMENTS[24141] = Fluid3D([18602,18627,18663,18600],0); -ELEMENTS[24142] = Fluid3D([17653,17793,17420,17788],0); -ELEMENTS[24143] = Fluid3D([12603,11787,12099,11726],0); -ELEMENTS[24144] = Fluid3D([11787,12099,11726,10984],0); -ELEMENTS[24145] = Fluid3D([12603,11787,11726,12204],0); -ELEMENTS[24146] = Fluid3D([12099,12603,11726,12738],0); -ELEMENTS[24147] = Fluid3D([12099,12603,12738,13145],0); -ELEMENTS[24148] = Fluid3D([12603,12738,13145,13858],0); -ELEMENTS[24149] = Fluid3D([3410,3231,3482,2954],0); -ELEMENTS[24150] = Fluid3D([4610,4286,4094,3834],0); -ELEMENTS[24151] = Fluid3D([4286,4094,3834,3643],0); -ELEMENTS[24152] = Fluid3D([16348,16848,16595,16542],0); -ELEMENTS[24153] = Fluid3D([10049,9865,9165,9355],0); -ELEMENTS[24154] = Fluid3D([9165,10049,9355,8618],0); -ELEMENTS[24155] = Fluid3D([9355,9165,8618,8881],0); -ELEMENTS[24156] = Fluid3D([9165,8618,8881,8153],0); -ELEMENTS[24157] = Fluid3D([8618,8881,8153,7899],0); -ELEMENTS[24158] = Fluid3D([8881,8153,7899,8912],0); -ELEMENTS[24159] = Fluid3D([8618,9355,8881,8405],0); -ELEMENTS[24160] = Fluid3D([9355,9165,8881,9865],0); -ELEMENTS[24161] = Fluid3D([8881,9165,8153,8912],0); -ELEMENTS[24162] = Fluid3D([10049,9865,9355,10524],0); -ELEMENTS[24163] = Fluid3D([16231,16661,16147,16591],0); -ELEMENTS[24164] = Fluid3D([7663,7191,7422,8025],0); -ELEMENTS[24165] = Fluid3D([14108,13375,13858,13898],0); -ELEMENTS[24166] = Fluid3D([16272,16007,16297,15759],0); -ELEMENTS[24167] = Fluid3D([16297,16272,15759,16001],0); -ELEMENTS[24168] = Fluid3D([16272,15759,16001,15834],0); -ELEMENTS[24169] = Fluid3D([16272,16007,15759,15775],0); -ELEMENTS[24170] = Fluid3D([16272,15759,15834,15775],0); -ELEMENTS[24171] = Fluid3D([15759,16001,15834,15163],0); -ELEMENTS[24172] = Fluid3D([16297,16272,16001,16778],0); -ELEMENTS[24173] = Fluid3D([16007,16297,15759,15517],0); -ELEMENTS[24174] = Fluid3D([15759,16297,16001,15847],0); -ELEMENTS[24175] = Fluid3D([15759,16297,15847,15517],0); -ELEMENTS[24176] = Fluid3D([16297,16001,15847,16468],0); -ELEMENTS[24177] = Fluid3D([16001,15759,15847,15163],0); -ELEMENTS[24178] = Fluid3D([16001,16272,15834,16426],0); -ELEMENTS[24179] = Fluid3D([16001,16272,16426,16778],0); -ELEMENTS[24180] = Fluid3D([16272,15834,16426,16372],0); -ELEMENTS[24181] = Fluid3D([15834,16001,16426,15950],0); -ELEMENTS[24182] = Fluid3D([15834,16001,15950,15459],0); -ELEMENTS[24183] = Fluid3D([15834,16001,15459,15163],0); -ELEMENTS[24184] = Fluid3D([15459,15834,15163,15424],0); -ELEMENTS[24185] = Fluid3D([15459,15834,15424,15950],0); -ELEMENTS[24186] = Fluid3D([16426,15834,15950,15877],0); -ELEMENTS[24187] = Fluid3D([15834,15424,15950,15877],0); -ELEMENTS[24188] = Fluid3D([16001,16426,15950,16500],0); -ELEMENTS[24189] = Fluid3D([16001,15950,15459,16096],0); -ELEMENTS[24190] = Fluid3D([16001,15950,16096,16500],0); -ELEMENTS[24191] = Fluid3D([15459,16001,16096,15847],0); -ELEMENTS[24192] = Fluid3D([15950,15459,16096,15658],0); -ELEMENTS[24193] = Fluid3D([16001,16096,15847,16468],0); -ELEMENTS[24194] = Fluid3D([16001,16096,16468,16500],0); -ELEMENTS[24195] = Fluid3D([16096,15950,15658,15927],0); -ELEMENTS[24196] = Fluid3D([16096,15950,15927,16500],0); -ELEMENTS[24197] = Fluid3D([15950,15658,15927,14933],0); -ELEMENTS[24198] = Fluid3D([16297,16001,16468,16778],0); -ELEMENTS[24199] = Fluid3D([7941,8815,8550,8353],0); -ELEMENTS[24200] = Fluid3D([8550,7941,8353,7621],0); -ELEMENTS[24201] = Fluid3D([9466,9923,10357,10978],0); -ELEMENTS[24202] = Fluid3D([16157,15780,15974,15667],0); -ELEMENTS[24203] = Fluid3D([15974,16157,15667,16348],0); -ELEMENTS[24204] = Fluid3D([6788,7062,6314,7040],0); -ELEMENTS[24205] = Fluid3D([7062,6314,7040,6457],0); -ELEMENTS[24206] = Fluid3D([6314,6788,7040,6020],0); -ELEMENTS[24207] = Fluid3D([6788,7062,7040,7629],0); -ELEMENTS[24208] = Fluid3D([7062,7040,7629,7692],0); -ELEMENTS[24209] = Fluid3D([6788,7062,7629,7180],0); -ELEMENTS[24210] = Fluid3D([7040,6788,7629,6879],0); -ELEMENTS[24211] = Fluid3D([4663,4695,4653,4287],0); -ELEMENTS[24212] = Fluid3D([4663,4695,4287,4606],0); -ELEMENTS[24213] = Fluid3D([4695,4653,4287,4365],0); -ELEMENTS[24214] = Fluid3D([4653,4663,4287,4377],0); -ELEMENTS[24215] = Fluid3D([4663,4287,4377,4293],0); -ELEMENTS[24216] = Fluid3D([4653,4663,4377,5028],0); -ELEMENTS[24217] = Fluid3D([4287,4377,4293,3917],0); -ELEMENTS[24218] = Fluid3D([4287,4653,4377,4315],0); -ELEMENTS[24219] = Fluid3D([4287,4653,4315,4365],0); -ELEMENTS[24220] = Fluid3D([4653,4377,4315,4759],0); -ELEMENTS[24221] = Fluid3D([4315,4653,4759,4788],0); -ELEMENTS[24222] = Fluid3D([4663,4287,4293,4606],0); -ELEMENTS[24223] = Fluid3D([4377,4663,4293,4541],0); -ELEMENTS[24224] = Fluid3D([13305,13270,14068,13358],0); -ELEMENTS[24225] = Fluid3D([10117,10559,10831,11447],0); -ELEMENTS[24226] = Fluid3D([16349,16147,16546,16022],0); -ELEMENTS[24227] = Fluid3D([16147,16546,16022,15918],0); -ELEMENTS[24228] = Fluid3D([16022,16147,15918,15566],0); -ELEMENTS[24229] = Fluid3D([15918,16022,15566,15721],0); -ELEMENTS[24230] = Fluid3D([16022,15566,15721,15878],0); -ELEMENTS[24231] = Fluid3D([15918,16022,15721,16288],0); -ELEMENTS[24232] = Fluid3D([15918,16022,16288,16546],0); -ELEMENTS[24233] = Fluid3D([16022,15721,16288,15878],0); -ELEMENTS[24234] = Fluid3D([15721,15918,16288,15899],0); -ELEMENTS[24235] = Fluid3D([15918,16288,15899,16570],0); -ELEMENTS[24236] = Fluid3D([16022,16288,16546,16565],0); -ELEMENTS[24237] = Fluid3D([15721,15918,15899,15380],0); -ELEMENTS[24238] = Fluid3D([15918,15899,15380,15944],0); -ELEMENTS[24239] = Fluid3D([15380,15918,15944,15175],0); -ELEMENTS[24240] = Fluid3D([16288,15721,15899,15986],0); -ELEMENTS[24241] = Fluid3D([15899,16288,15986,16395],0); -ELEMENTS[24242] = Fluid3D([15899,16288,16395,16570],0); -ELEMENTS[24243] = Fluid3D([16288,16395,16570,16705],0); -ELEMENTS[24244] = Fluid3D([16395,16570,16705,16914],0); -ELEMENTS[24245] = Fluid3D([16705,16395,16914,16985],0); -ELEMENTS[24246] = Fluid3D([16288,16395,16705,15986],0); -ELEMENTS[24247] = Fluid3D([16395,16570,16914,16385],0); -ELEMENTS[24248] = Fluid3D([16395,16570,16385,15899],0); -ELEMENTS[24249] = Fluid3D([16570,16288,16705,16743],0); -ELEMENTS[24250] = Fluid3D([16570,16288,16743,16546],0); -ELEMENTS[24251] = Fluid3D([16288,16743,16546,16565],0); -ELEMENTS[24252] = Fluid3D([16914,16395,16385,16505],0); -ELEMENTS[24253] = Fluid3D([16395,16385,16505,15976],0); -ELEMENTS[24254] = Fluid3D([16395,16385,15976,15899],0); -ELEMENTS[24255] = Fluid3D([15976,16395,15899,15986],0); -ELEMENTS[24256] = Fluid3D([16288,16705,16743,16704],0); -ELEMENTS[24257] = Fluid3D([16914,16395,16505,16985],0); -ELEMENTS[24258] = Fluid3D([16505,16395,15976,16221],0); -ELEMENTS[24259] = Fluid3D([16395,15976,16221,15986],0); -ELEMENTS[24260] = Fluid3D([16385,16505,15976,16187],0); -ELEMENTS[24261] = Fluid3D([15976,16385,16187,15840],0); -ELEMENTS[24262] = Fluid3D([15976,16385,15840,15899],0); -ELEMENTS[24263] = Fluid3D([16022,16147,15566,16349],0); -ELEMENTS[24264] = Fluid3D([16570,16914,16385,16830],0); -ELEMENTS[24265] = Fluid3D([16385,16505,16187,16727],0); -ELEMENTS[24266] = Fluid3D([15721,15918,15380,15566],0); -ELEMENTS[24267] = Fluid3D([15899,15380,15944,15308],0); -ELEMENTS[24268] = Fluid3D([16385,16187,15840,16560],0); -ELEMENTS[24269] = Fluid3D([16505,16395,16221,16985],0); -ELEMENTS[24270] = Fluid3D([15918,15899,15944,16570],0); -ELEMENTS[24271] = Fluid3D([16187,15976,15840,15802],0); -ELEMENTS[24272] = Fluid3D([15840,16187,15802,16178],0); -ELEMENTS[24273] = Fluid3D([16187,15802,16178,16159],0); -ELEMENTS[24274] = Fluid3D([15721,15899,15986,15398],0); -ELEMENTS[24275] = Fluid3D([15899,15986,15398,15976],0); -ELEMENTS[24276] = Fluid3D([15721,15899,15398,15380],0); -ELEMENTS[24277] = Fluid3D([15976,16505,16221,16044],0); -ELEMENTS[24278] = Fluid3D([16505,16221,16044,16547],0); -ELEMENTS[24279] = Fluid3D([16505,16221,16547,16985],0); -ELEMENTS[24280] = Fluid3D([16221,15976,16044,15626],0); -ELEMENTS[24281] = Fluid3D([16221,15976,15626,15986],0); -ELEMENTS[24282] = Fluid3D([15976,16505,16044,16187],0); -ELEMENTS[24283] = Fluid3D([16221,16044,16547,16074],0); -ELEMENTS[24284] = Fluid3D([16221,16044,16074,15626],0); -ELEMENTS[24285] = Fluid3D([16547,16221,16074,16674],0); -ELEMENTS[24286] = Fluid3D([16044,16547,16074,16454],0); -ELEMENTS[24287] = Fluid3D([16044,16505,16547,16541],0); -ELEMENTS[24288] = Fluid3D([16505,16547,16541,17020],0); -ELEMENTS[24289] = Fluid3D([16044,16505,16541,16187],0); -ELEMENTS[24290] = Fluid3D([16547,16044,16541,16454],0); -ELEMENTS[24291] = Fluid3D([15976,16044,15626,15802],0); -ELEMENTS[24292] = Fluid3D([16546,16349,16022,16565],0); -ELEMENTS[24293] = Fluid3D([15986,15721,15398,15403],0); -ELEMENTS[24294] = Fluid3D([16385,16914,16505,16727],0); -ELEMENTS[24295] = Fluid3D([16288,15721,15986,15878],0); -ELEMENTS[24296] = Fluid3D([12669,13212,13487,13479],0); -ELEMENTS[24297] = Fluid3D([9709,8748,9130,9073],0); -ELEMENTS[24298] = Fluid3D([8748,9130,9073,8073],0); -ELEMENTS[24299] = Fluid3D([9130,9709,9073,9896],0); -ELEMENTS[24300] = Fluid3D([9073,9130,9896,8990],0); -ELEMENTS[24301] = Fluid3D([9896,9073,8990,9498],0); -ELEMENTS[24302] = Fluid3D([8990,9896,9498,9909],0); -ELEMENTS[24303] = Fluid3D([8990,9896,9909,9475],0); -ELEMENTS[24304] = Fluid3D([9709,8748,9073,8591],0); -ELEMENTS[24305] = Fluid3D([8748,9073,8591,8073],0); -ELEMENTS[24306] = Fluid3D([9896,9073,9498,9788],0); -ELEMENTS[24307] = Fluid3D([9130,9709,9896,10089],0); -ELEMENTS[24308] = Fluid3D([9498,8990,9909,9183],0); -ELEMENTS[24309] = Fluid3D([8990,9909,9183,9475],0); -ELEMENTS[24310] = Fluid3D([9498,8990,9183,8176],0); -ELEMENTS[24311] = Fluid3D([9909,9498,9183,10318],0); -ELEMENTS[24312] = Fluid3D([9130,9896,8990,9475],0); -ELEMENTS[24313] = Fluid3D([9896,9498,9909,10706],0); -ELEMENTS[24314] = Fluid3D([9709,9073,9896,9788],0); -ELEMENTS[24315] = Fluid3D([9073,9130,8990,8216],0); -ELEMENTS[24316] = Fluid3D([9073,9130,8216,8073],0); -ELEMENTS[24317] = Fluid3D([9130,8990,8216,8547],0); -ELEMENTS[24318] = Fluid3D([8990,8216,8547,8281],0); -ELEMENTS[24319] = Fluid3D([8547,8990,8281,8428],0); -ELEMENTS[24320] = Fluid3D([8990,8216,8281,8176],0); -ELEMENTS[24321] = Fluid3D([8990,9073,8216,8176],0); -ELEMENTS[24322] = Fluid3D([9073,8990,9498,8176],0); -ELEMENTS[24323] = Fluid3D([15146,15232,14516,14973],0); -ELEMENTS[24324] = Fluid3D([15146,15232,14973,15797],0); -ELEMENTS[24325] = Fluid3D([14516,15146,14973,14180],0); -ELEMENTS[24326] = Fluid3D([15232,14516,14973,14704],0); -ELEMENTS[24327] = Fluid3D([14973,15232,14704,15244],0); -ELEMENTS[24328] = Fluid3D([15232,14704,15244,15385],0); -ELEMENTS[24329] = Fluid3D([15232,14516,14704,14869],0); -ELEMENTS[24330] = Fluid3D([15232,14516,14869,15087],0); -ELEMENTS[24331] = Fluid3D([14516,14704,14869,13775],0); -ELEMENTS[24332] = Fluid3D([15244,15232,15385,15864],0); -ELEMENTS[24333] = Fluid3D([15385,15244,15864,15909],0); -ELEMENTS[24334] = Fluid3D([15385,15244,15909,15399],0); -ELEMENTS[24335] = Fluid3D([15244,15864,15909,15936],0); -ELEMENTS[24336] = Fluid3D([15244,15864,15936,15797],0); -ELEMENTS[24337] = Fluid3D([15864,15936,15797,16433],0); -ELEMENTS[24338] = Fluid3D([15797,15864,16433,16217],0); -ELEMENTS[24339] = Fluid3D([15909,15244,15936,15836],0); -ELEMENTS[24340] = Fluid3D([15864,15385,15909,16032],0); -ELEMENTS[24341] = Fluid3D([15864,15936,16433,16527],0); -ELEMENTS[24342] = Fluid3D([16433,15864,16527,16510],0); -ELEMENTS[24343] = Fluid3D([16527,16433,16510,16789],0); -ELEMENTS[24344] = Fluid3D([16527,16433,16789,16726],0); -ELEMENTS[24345] = Fluid3D([16433,16510,16789,16659],0); -ELEMENTS[24346] = Fluid3D([16510,16789,16659,16620],0); -ELEMENTS[24347] = Fluid3D([16659,16510,16620,16219],0); -ELEMENTS[24348] = Fluid3D([15936,16433,16527,16365],0); -ELEMENTS[24349] = Fluid3D([16433,15864,16510,16217],0); -ELEMENTS[24350] = Fluid3D([16510,16527,16789,16794],0); -ELEMENTS[24351] = Fluid3D([16527,16789,16794,17060],0); -ELEMENTS[24352] = Fluid3D([16789,16794,17060,17258],0); -ELEMENTS[24353] = Fluid3D([16527,16789,17060,16726],0); -ELEMENTS[24354] = Fluid3D([16789,17060,16726,16945],0); -ELEMENTS[24355] = Fluid3D([16789,17060,16945,17180],0); -ELEMENTS[24356] = Fluid3D([16789,17060,17180,17258],0); -ELEMENTS[24357] = Fluid3D([16945,16789,17180,16672],0); -ELEMENTS[24358] = Fluid3D([16726,16789,16945,16433],0); -ELEMENTS[24359] = Fluid3D([16789,16945,16433,16672],0); -ELEMENTS[24360] = Fluid3D([16433,16510,16659,16217],0); -ELEMENTS[24361] = Fluid3D([16510,16659,16217,16219],0); -ELEMENTS[24362] = Fluid3D([15244,15232,15864,15797],0); -ELEMENTS[24363] = Fluid3D([16510,16527,16794,16340],0); -ELEMENTS[24364] = Fluid3D([16527,16794,16340,16369],0); -ELEMENTS[24365] = Fluid3D([16794,16510,16340,16783],0); -ELEMENTS[24366] = Fluid3D([16340,16794,16783,16977],0); -ELEMENTS[24367] = Fluid3D([16794,16783,16977,17258],0); -ELEMENTS[24368] = Fluid3D([16527,16433,16726,16365],0); -ELEMENTS[24369] = Fluid3D([15864,15909,15936,16527],0); -ELEMENTS[24370] = Fluid3D([16510,16527,16340,15864],0); -ELEMENTS[24371] = Fluid3D([14516,14973,14704,14191],0); -ELEMENTS[24372] = Fluid3D([14516,14973,14191,14180],0); -ELEMENTS[24373] = Fluid3D([14973,14704,14191,14321],0); -ELEMENTS[24374] = Fluid3D([14704,14191,14321,13775],0); -ELEMENTS[24375] = Fluid3D([14321,14704,13775,14341],0); -ELEMENTS[24376] = Fluid3D([14321,14704,14341,14625],0); -ELEMENTS[24377] = Fluid3D([14704,13775,14341,14869],0); -ELEMENTS[24378] = Fluid3D([14341,14704,14869,15385],0); -ELEMENTS[24379] = Fluid3D([14191,14321,13775,13783],0); -ELEMENTS[24380] = Fluid3D([13775,14191,13783,13542],0); -ELEMENTS[24381] = Fluid3D([14191,13783,13542,14049],0); -ELEMENTS[24382] = Fluid3D([14321,14704,14625,15399],0); -ELEMENTS[24383] = Fluid3D([13775,14191,13542,14516],0); -ELEMENTS[24384] = Fluid3D([14704,14191,13775,14516],0); -ELEMENTS[24385] = Fluid3D([14704,14973,15244,14321],0); -ELEMENTS[24386] = Fluid3D([15244,14704,14321,15399],0); -ELEMENTS[24387] = Fluid3D([16789,16510,16794,16911],0); -ELEMENTS[24388] = Fluid3D([16794,16789,16911,17258],0); -ELEMENTS[24389] = Fluid3D([16911,16794,17258,16783],0); -ELEMENTS[24390] = Fluid3D([16911,16794,16783,16620],0); -ELEMENTS[24391] = Fluid3D([17258,16911,16783,16870],0); -ELEMENTS[24392] = Fluid3D([16911,16794,16620,16510],0); -ELEMENTS[24393] = Fluid3D([16620,16911,16510,16789],0); -ELEMENTS[24394] = Fluid3D([16783,16911,16620,16870],0); -ELEMENTS[24395] = Fluid3D([17258,16911,16870,16980],0); -ELEMENTS[24396] = Fluid3D([17258,16911,16980,16789],0); -ELEMENTS[24397] = Fluid3D([16911,16870,16980,16789],0); -ELEMENTS[24398] = Fluid3D([16794,16620,16510,16783],0); -ELEMENTS[24399] = Fluid3D([16870,17258,16980,17341],0); -ELEMENTS[24400] = Fluid3D([16911,16620,16870,16789],0); -ELEMENTS[24401] = Fluid3D([14973,15232,15244,15797],0); -ELEMENTS[24402] = Fluid3D([14704,15232,14869,15385],0); -ELEMENTS[24403] = Fluid3D([16410,16807,16454,16074],0); -ELEMENTS[24404] = Fluid3D([7105,7892,8009,8104],0); -ELEMENTS[24405] = Fluid3D([7105,7892,8104,7495],0); -ELEMENTS[24406] = Fluid3D([8009,7105,8104,7605],0); -ELEMENTS[24407] = Fluid3D([7892,8009,8104,8889],0); -ELEMENTS[24408] = Fluid3D([5390,6040,5607,5823],0); -ELEMENTS[24409] = Fluid3D([10674,10173,11281,10392],0); -ELEMENTS[24410] = Fluid3D([9098,8754,9330,8398],0); -ELEMENTS[24411] = Fluid3D([17141,16846,16704,16619],0); -ELEMENTS[24412] = Fluid3D([2337,2572,2614,2385],0); -ELEMENTS[24413] = Fluid3D([7279,7911,7706,7297],0); -ELEMENTS[24414] = Fluid3D([14350,13534,13990,13282],0); -ELEMENTS[24415] = Fluid3D([18333,18368,18380,18210],0); -ELEMENTS[24416] = Fluid3D([18368,18380,18210,18453],0); -ELEMENTS[24417] = Fluid3D([18333,18368,18210,18238],0); -ELEMENTS[24418] = Fluid3D([18368,18210,18238,18212],0); -ELEMENTS[24419] = Fluid3D([18368,18210,18212,18401],0); -ELEMENTS[24420] = Fluid3D([9493,9681,10241,10333],0); -ELEMENTS[24421] = Fluid3D([10241,9493,10333,10145],0); -ELEMENTS[24422] = Fluid3D([9493,9681,10333,9698],0); -ELEMENTS[24423] = Fluid3D([9493,9681,9698,8829],0); -ELEMENTS[24424] = Fluid3D([10333,9493,9698,9638],0); -ELEMENTS[24425] = Fluid3D([9493,9698,9638,8829],0); -ELEMENTS[24426] = Fluid3D([10333,9493,9638,10145],0); -ELEMENTS[24427] = Fluid3D([9698,10333,9638,10388],0); -ELEMENTS[24428] = Fluid3D([9638,9698,10388,8969],0); -ELEMENTS[24429] = Fluid3D([9698,10333,10388,10296],0); -ELEMENTS[24430] = Fluid3D([10388,9698,10296,9955],0); -ELEMENTS[24431] = Fluid3D([9638,9698,8969,8829],0); -ELEMENTS[24432] = Fluid3D([9698,10333,10296,9681],0); -ELEMENTS[24433] = Fluid3D([10296,9698,9681,9402],0); -ELEMENTS[24434] = Fluid3D([10296,9698,9402,9955],0); -ELEMENTS[24435] = Fluid3D([9698,9681,9402,8829],0); -ELEMENTS[24436] = Fluid3D([9681,10296,9402,10033],0); -ELEMENTS[24437] = Fluid3D([10296,9402,10033,10134],0); -ELEMENTS[24438] = Fluid3D([10296,9402,10134,9955],0); -ELEMENTS[24439] = Fluid3D([10033,10296,10134,10976],0); -ELEMENTS[24440] = Fluid3D([10296,10134,10976,10967],0); -ELEMENTS[24441] = Fluid3D([9402,10033,10134,9894],0); -ELEMENTS[24442] = Fluid3D([10033,10134,9894,10976],0); -ELEMENTS[24443] = Fluid3D([9894,10033,10976,10242],0); -ELEMENTS[24444] = Fluid3D([9894,10033,10242,9223],0); -ELEMENTS[24445] = Fluid3D([10033,10242,9223,9681],0); -ELEMENTS[24446] = Fluid3D([9894,10033,9223,9402],0); -ELEMENTS[24447] = Fluid3D([10976,10296,10967,11412],0); -ELEMENTS[24448] = Fluid3D([10296,10134,10967,9955],0); -ELEMENTS[24449] = Fluid3D([10033,10296,10976,10634],0); -ELEMENTS[24450] = Fluid3D([10296,10967,11412,10388],0); -ELEMENTS[24451] = Fluid3D([10134,10976,10967,11045],0); -ELEMENTS[24452] = Fluid3D([10033,10976,10242,10634],0); -ELEMENTS[24453] = Fluid3D([10242,10033,10634,9681],0); -ELEMENTS[24454] = Fluid3D([10976,10967,11045,12179],0); -ELEMENTS[24455] = Fluid3D([9681,10296,10033,10634],0); -ELEMENTS[24456] = Fluid3D([10134,10976,11045,9894],0); -ELEMENTS[24457] = Fluid3D([10976,10296,11412,10866],0); -ELEMENTS[24458] = Fluid3D([10976,10296,10866,10634],0); -ELEMENTS[24459] = Fluid3D([10296,11412,10866,10880],0); -ELEMENTS[24460] = Fluid3D([10296,11412,10880,10388],0); -ELEMENTS[24461] = Fluid3D([10866,10296,10880,10333],0); -ELEMENTS[24462] = Fluid3D([10296,10880,10333,10388],0); -ELEMENTS[24463] = Fluid3D([10880,10866,10333,10890],0); -ELEMENTS[24464] = Fluid3D([10333,10880,10890,10837],0); -ELEMENTS[24465] = Fluid3D([10333,10880,10837,10388],0); -ELEMENTS[24466] = Fluid3D([10880,10866,10890,11683],0); -ELEMENTS[24467] = Fluid3D([10890,10880,11683,11871],0); -ELEMENTS[24468] = Fluid3D([10890,10880,11871,10837],0); -ELEMENTS[24469] = Fluid3D([10880,11871,10837,11683],0); -ELEMENTS[24470] = Fluid3D([10866,10333,10890,10241],0); -ELEMENTS[24471] = Fluid3D([10333,10890,10241,10451],0); -ELEMENTS[24472] = Fluid3D([10333,10890,10451,10837],0); -ELEMENTS[24473] = Fluid3D([10890,10241,10451,10742],0); -ELEMENTS[24474] = Fluid3D([10890,10241,10742,10788],0); -ELEMENTS[24475] = Fluid3D([10890,10241,10788,10866],0); -ELEMENTS[24476] = Fluid3D([10451,10333,10837,10145],0); -ELEMENTS[24477] = Fluid3D([11683,10890,11871,12082],0); -ELEMENTS[24478] = Fluid3D([10451,10890,10742,12082],0); -ELEMENTS[24479] = Fluid3D([11683,10890,12082,11548],0); -ELEMENTS[24480] = Fluid3D([11683,10890,11548,10866],0); -ELEMENTS[24481] = Fluid3D([10890,11548,10866,10788],0); -ELEMENTS[24482] = Fluid3D([10890,11548,10788,12082],0); -ELEMENTS[24483] = Fluid3D([10890,11871,12082,10451],0); -ELEMENTS[24484] = Fluid3D([10890,11871,10451,10837],0); -ELEMENTS[24485] = Fluid3D([11871,10451,10837,11288],0); -ELEMENTS[24486] = Fluid3D([10837,11871,11288,11936],0); -ELEMENTS[24487] = Fluid3D([10837,11871,11936,11516],0); -ELEMENTS[24488] = Fluid3D([11871,11288,11936,12381],0); -ELEMENTS[24489] = Fluid3D([11871,10451,11288,12252],0); -ELEMENTS[24490] = Fluid3D([10837,10451,10145,11288],0); -ELEMENTS[24491] = Fluid3D([10451,10145,11288,10628],0); -ELEMENTS[24492] = Fluid3D([11548,10866,10788,10634],0); -ELEMENTS[24493] = Fluid3D([11548,10866,10634,11852],0); -ELEMENTS[24494] = Fluid3D([10788,11548,10634,11656],0); -ELEMENTS[24495] = Fluid3D([10866,10788,10634,10241],0); -ELEMENTS[24496] = Fluid3D([10742,10890,10788,12082],0); -ELEMENTS[24497] = Fluid3D([11548,11683,10866,11852],0); -ELEMENTS[24498] = Fluid3D([10241,10742,10788,10099],0); -ELEMENTS[24499] = Fluid3D([10880,10866,11683,11412],0); -ELEMENTS[24500] = Fluid3D([11683,10880,11412,11516],0); -ELEMENTS[24501] = Fluid3D([10866,11683,11412,11852],0); -ELEMENTS[24502] = Fluid3D([10241,10742,10099,10147],0); -ELEMENTS[24503] = Fluid3D([10241,10451,10742,10079],0); -ELEMENTS[24504] = Fluid3D([10742,10241,10079,10147],0); -ELEMENTS[24505] = Fluid3D([10079,10742,10147,10582],0); -ELEMENTS[24506] = Fluid3D([10147,10079,10582,9353],0); -ELEMENTS[24507] = Fluid3D([10147,10079,9353,8950],0); -ELEMENTS[24508] = Fluid3D([10147,10079,8950,9335],0); -ELEMENTS[24509] = Fluid3D([10147,10079,9335,10241],0); -ELEMENTS[24510] = Fluid3D([10079,10742,10582,10451],0); -ELEMENTS[24511] = Fluid3D([10241,10333,10451,10145],0); -ELEMENTS[24512] = Fluid3D([10788,10241,10099,9858],0); -ELEMENTS[24513] = Fluid3D([12082,11683,11548,12450],0); -ELEMENTS[24514] = Fluid3D([10880,10837,10388,11516],0); -ELEMENTS[24515] = Fluid3D([10742,10788,10099,11726],0); -ELEMENTS[24516] = Fluid3D([11871,11683,12082,12332],0); -ELEMENTS[24517] = Fluid3D([11683,12082,12332,12450],0); -ELEMENTS[24518] = Fluid3D([10241,10451,10079,9357],0); -ELEMENTS[24519] = Fluid3D([11871,11683,12332,11516],0); -ELEMENTS[24520] = Fluid3D([11412,10976,10866,11852],0); -ELEMENTS[24521] = Fluid3D([10967,10134,11045,10695],0); -ELEMENTS[24522] = Fluid3D([9681,10241,10333,10296],0); -ELEMENTS[24523] = Fluid3D([10967,10976,11412,12179],0); -ELEMENTS[24524] = Fluid3D([9402,9681,10033,9223],0); -ELEMENTS[24525] = Fluid3D([17078,17354,17510,17215],0); -ELEMENTS[24526] = Fluid3D([13430,13464,13319,14253],0); -ELEMENTS[24527] = Fluid3D([5811,5558,5473,5135],0); -ELEMENTS[24528] = Fluid3D([7153,6591,6776,7445],0); -ELEMENTS[24529] = Fluid3D([15239,15156,15030,15654],0); -ELEMENTS[24530] = Fluid3D([15030,15239,15654,15698],0); -ELEMENTS[24531] = Fluid3D([15239,15156,15654,15676],0); -ELEMENTS[24532] = Fluid3D([15156,15030,15654,15320],0); -ELEMENTS[24533] = Fluid3D([15030,15654,15320,15934],0); -ELEMENTS[24534] = Fluid3D([15654,15156,15320,15747],0); -ELEMENTS[24535] = Fluid3D([15320,15654,15747,16158],0); -ELEMENTS[24536] = Fluid3D([15654,15156,15747,15676],0); -ELEMENTS[24537] = Fluid3D([15156,15030,15320,14539],0); -ELEMENTS[24538] = Fluid3D([15156,15320,15747,15164],0); -ELEMENTS[24539] = Fluid3D([15320,15747,15164,15702],0); -ELEMENTS[24540] = Fluid3D([15156,15320,15164,14539],0); -ELEMENTS[24541] = Fluid3D([15747,15156,15164,15396],0); -ELEMENTS[24542] = Fluid3D([8115,8741,9085,8326],0); -ELEMENTS[24543] = Fluid3D([8115,8741,8326,7363],0); -ELEMENTS[24544] = Fluid3D([8741,9085,8326,9128],0); -ELEMENTS[24545] = Fluid3D([8741,9085,9128,9543],0); -ELEMENTS[24546] = Fluid3D([8326,8741,9128,8204],0); -ELEMENTS[24547] = Fluid3D([8326,8741,8204,7363],0); -ELEMENTS[24548] = Fluid3D([8741,9128,8204,9365],0); -ELEMENTS[24549] = Fluid3D([9085,8115,8326,8534],0); -ELEMENTS[24550] = Fluid3D([8115,8326,8534,7626],0); -ELEMENTS[24551] = Fluid3D([8326,8534,7626,8227],0); -ELEMENTS[24552] = Fluid3D([8534,7626,8227,7520],0); -ELEMENTS[24553] = Fluid3D([7626,8227,7520,7409],0); -ELEMENTS[24554] = Fluid3D([7520,7626,7409,6867],0); -ELEMENTS[24555] = Fluid3D([9085,8115,8534,8790],0); -ELEMENTS[24556] = Fluid3D([8115,8534,8790,7970],0); -ELEMENTS[24557] = Fluid3D([8115,8534,7970,7626],0); -ELEMENTS[24558] = Fluid3D([8790,8115,7970,8311],0); -ELEMENTS[24559] = Fluid3D([9085,8115,8790,8688],0); -ELEMENTS[24560] = Fluid3D([8326,8534,8227,9103],0); -ELEMENTS[24561] = Fluid3D([8326,8534,9103,9085],0); -ELEMENTS[24562] = Fluid3D([8227,8326,9103,8515],0); -ELEMENTS[24563] = Fluid3D([8534,8227,9103,9041],0); -ELEMENTS[24564] = Fluid3D([9103,8534,9041,9495],0); -ELEMENTS[24565] = Fluid3D([9103,8534,9495,9085],0); -ELEMENTS[24566] = Fluid3D([8534,8227,9041,8055],0); -ELEMENTS[24567] = Fluid3D([8534,8227,8055,7520],0); -ELEMENTS[24568] = Fluid3D([8227,8055,7520,8076],0); -ELEMENTS[24569] = Fluid3D([8055,7520,8076,7188],0); -ELEMENTS[24570] = Fluid3D([7520,8227,8076,8341],0); -ELEMENTS[24571] = Fluid3D([8227,8055,8076,9041],0); -ELEMENTS[24572] = Fluid3D([8227,8076,8341,9057],0); -ELEMENTS[24573] = Fluid3D([8341,8227,9057,9103],0); -ELEMENTS[24574] = Fluid3D([9041,8534,8055,8785],0); -ELEMENTS[24575] = Fluid3D([9041,8534,8785,9495],0); -ELEMENTS[24576] = Fluid3D([8534,8055,8785,7970],0); -ELEMENTS[24577] = Fluid3D([8055,9041,8785,8759],0); -ELEMENTS[24578] = Fluid3D([9041,8785,8759,9553],0); -ELEMENTS[24579] = Fluid3D([9041,8785,9553,9495],0); -ELEMENTS[24580] = Fluid3D([9553,9041,9495,9835],0); -ELEMENTS[24581] = Fluid3D([9553,9041,9835,9811],0); -ELEMENTS[24582] = Fluid3D([8759,9041,9553,9811],0); -ELEMENTS[24583] = Fluid3D([9495,9553,9835,10424],0); -ELEMENTS[24584] = Fluid3D([9553,9835,10424,10405],0); -ELEMENTS[24585] = Fluid3D([9553,9835,10405,9811],0); -ELEMENTS[24586] = Fluid3D([10424,9553,10405,9992],0); -ELEMENTS[24587] = Fluid3D([9041,9495,9835,9103],0); -ELEMENTS[24588] = Fluid3D([9835,10424,10405,10883],0); -ELEMENTS[24589] = Fluid3D([10405,9835,10883,10637],0); -ELEMENTS[24590] = Fluid3D([10883,10405,10637,11768],0); -ELEMENTS[24591] = Fluid3D([9835,10424,10883,10307],0); -ELEMENTS[24592] = Fluid3D([9835,10424,10307,9495],0); -ELEMENTS[24593] = Fluid3D([10883,9835,10307,10283],0); -ELEMENTS[24594] = Fluid3D([10883,9835,10283,9894],0); -ELEMENTS[24595] = Fluid3D([9495,9553,10424,9381],0); -ELEMENTS[24596] = Fluid3D([9495,9553,9381,8785],0); -ELEMENTS[24597] = Fluid3D([9553,9381,8785,9033],0); -ELEMENTS[24598] = Fluid3D([9381,8785,9033,8590],0); -ELEMENTS[24599] = Fluid3D([8785,9033,8590,7867],0); -ELEMENTS[24600] = Fluid3D([8785,9553,9033,8759],0); -ELEMENTS[24601] = Fluid3D([9033,8785,8759,7867],0); -ELEMENTS[24602] = Fluid3D([9381,9495,8785,8790],0); -ELEMENTS[24603] = Fluid3D([9381,8785,8590,8790],0); -ELEMENTS[24604] = Fluid3D([9553,9033,8759,9609],0); -ELEMENTS[24605] = Fluid3D([9033,8759,9609,8702],0); -ELEMENTS[24606] = Fluid3D([9033,8759,8702,7867],0); -ELEMENTS[24607] = Fluid3D([10307,10883,10283,11173],0); -ELEMENTS[24608] = Fluid3D([10424,10883,10307,11236],0); -ELEMENTS[24609] = Fluid3D([10424,10405,10883,11768],0); -ELEMENTS[24610] = Fluid3D([8055,9041,8759,8076],0); -ELEMENTS[24611] = Fluid3D([10883,10283,11173,11045],0); -ELEMENTS[24612] = Fluid3D([8227,9103,9041,9057],0); -ELEMENTS[24613] = Fluid3D([9041,8227,9057,8076],0); -ELEMENTS[24614] = Fluid3D([9103,9041,9057,9835],0); -ELEMENTS[24615] = Fluid3D([9041,9057,9835,9811],0); -ELEMENTS[24616] = Fluid3D([8785,8055,8759,7867],0); -ELEMENTS[24617] = Fluid3D([8534,9085,8790,9495],0); -ELEMENTS[24618] = Fluid3D([8115,8326,7626,7363],0); -ELEMENTS[24619] = Fluid3D([9085,8326,9128,9103],0); -ELEMENTS[24620] = Fluid3D([10307,10883,11173,11236],0); -ELEMENTS[24621] = Fluid3D([11173,10307,11236,10968],0); -ELEMENTS[24622] = Fluid3D([10307,11236,10968,10471],0); -ELEMENTS[24623] = Fluid3D([10307,11236,10471,10424],0); -ELEMENTS[24624] = Fluid3D([10968,10307,10471,9800],0); -ELEMENTS[24625] = Fluid3D([10968,10307,9800,10058],0); -ELEMENTS[24626] = Fluid3D([10307,10471,9800,9495],0); -ELEMENTS[24627] = Fluid3D([11236,10968,10471,12020],0); -ELEMENTS[24628] = Fluid3D([11173,10307,10968,10396],0); -ELEMENTS[24629] = Fluid3D([10307,10968,10396,10058],0); -ELEMENTS[24630] = Fluid3D([10471,10968,9800,10579],0); -ELEMENTS[24631] = Fluid3D([10968,9800,10579,10058],0); -ELEMENTS[24632] = Fluid3D([9800,10471,10579,9471],0); -ELEMENTS[24633] = Fluid3D([11173,10307,10396,10283],0); -ELEMENTS[24634] = Fluid3D([10307,10396,10283,9103],0); -ELEMENTS[24635] = Fluid3D([10396,11173,10283,10875],0); -ELEMENTS[24636] = Fluid3D([10283,10396,10875,9820],0); -ELEMENTS[24637] = Fluid3D([10283,10396,9820,9103],0); -ELEMENTS[24638] = Fluid3D([10875,10283,9820,10134],0); -ELEMENTS[24639] = Fluid3D([10396,10875,9820,10314],0); -ELEMENTS[24640] = Fluid3D([11173,10283,10875,11045],0); -ELEMENTS[24641] = Fluid3D([10283,10875,11045,10134],0); -ELEMENTS[24642] = Fluid3D([10396,11173,10875,11249],0); -ELEMENTS[24643] = Fluid3D([10875,10396,11249,10314],0); -ELEMENTS[24644] = Fluid3D([10968,10396,10058,11249],0); -ELEMENTS[24645] = Fluid3D([11173,10875,11249,11855],0); -ELEMENTS[24646] = Fluid3D([10875,11249,11855,11420],0); -ELEMENTS[24647] = Fluid3D([11173,10875,11855,11045],0); -ELEMENTS[24648] = Fluid3D([10471,10968,10579,11386],0); -ELEMENTS[24649] = Fluid3D([10968,10579,11386,11387],0); -ELEMENTS[24650] = Fluid3D([10579,10471,11386,10434],0); -ELEMENTS[24651] = Fluid3D([10471,11386,10434,11326],0); -ELEMENTS[24652] = Fluid3D([10434,10471,11326,10459],0); -ELEMENTS[24653] = Fluid3D([10434,10471,10459,9471],0); -ELEMENTS[24654] = Fluid3D([10471,11386,11326,12020],0); -ELEMENTS[24655] = Fluid3D([11386,11326,12020,12524],0); -ELEMENTS[24656] = Fluid3D([11326,10434,10459,10606],0); -ELEMENTS[24657] = Fluid3D([10471,11326,10459,11236],0); -ELEMENTS[24658] = Fluid3D([10434,10471,9471,10579],0); -ELEMENTS[24659] = Fluid3D([10471,11326,11236,12020],0); -ELEMENTS[24660] = Fluid3D([10471,10968,11386,12020],0); -ELEMENTS[24661] = Fluid3D([10579,11386,11387,11321],0); -ELEMENTS[24662] = Fluid3D([10579,11386,11321,10218],0); -ELEMENTS[24663] = Fluid3D([11321,10579,10218,10970],0); -ELEMENTS[24664] = Fluid3D([11387,10579,11321,10970],0); -ELEMENTS[24665] = Fluid3D([11321,11387,10970,12141],0); -ELEMENTS[24666] = Fluid3D([11386,11387,11321,12675],0); -ELEMENTS[24667] = Fluid3D([10968,10579,11387,10534],0); -ELEMENTS[24668] = Fluid3D([10579,11387,10534,10970],0); -ELEMENTS[24669] = Fluid3D([11387,10968,10534,11249],0); -ELEMENTS[24670] = Fluid3D([10968,10579,10534,10058],0); -ELEMENTS[24671] = Fluid3D([10534,10968,10058,11249],0); -ELEMENTS[24672] = Fluid3D([10396,11173,11249,10968],0); -ELEMENTS[24673] = Fluid3D([7626,8326,8227,7409],0); -ELEMENTS[24674] = Fluid3D([11386,10968,11387,12020],0); -ELEMENTS[24675] = Fluid3D([11249,11173,11855,12001],0); -ELEMENTS[24676] = Fluid3D([11855,11249,12001,12441],0); -ELEMENTS[24677] = Fluid3D([11173,11855,12001,12152],0); -ELEMENTS[24678] = Fluid3D([11249,11173,12001,10968],0); -ELEMENTS[24679] = Fluid3D([9835,10307,10283,9103],0); -ELEMENTS[24680] = Fluid3D([9128,8326,8204,8515],0); -ELEMENTS[24681] = Fluid3D([8534,8790,7970,8785],0); -ELEMENTS[24682] = Fluid3D([13822,14137,14033,14854],0); -ELEMENTS[24683] = Fluid3D([14610,14447,15143,14821],0); -ELEMENTS[24684] = Fluid3D([14616,15277,14799,14507],0); -ELEMENTS[24685] = Fluid3D([12511,11729,12541,13073],0); -ELEMENTS[24686] = Fluid3D([12762,12443,12963,12282],0); -ELEMENTS[24687] = Fluid3D([12443,12963,12282,13057],0); -ELEMENTS[24688] = Fluid3D([12963,12762,12282,11682],0); -ELEMENTS[24689] = Fluid3D([12762,12443,12282,11866],0); -ELEMENTS[24690] = Fluid3D([8502,9469,9043,9022],0); -ELEMENTS[24691] = Fluid3D([9469,9043,9022,9876],0); -ELEMENTS[24692] = Fluid3D([9043,8502,9022,8044],0); -ELEMENTS[24693] = Fluid3D([8502,9022,8044,8491],0); -ELEMENTS[24694] = Fluid3D([9043,9022,9876,9149],0); -ELEMENTS[24695] = Fluid3D([9043,9022,9149,8044],0); -ELEMENTS[24696] = Fluid3D([9876,9043,9149,9697],0); -ELEMENTS[24697] = Fluid3D([9876,9043,9697,9919],0); -ELEMENTS[24698] = Fluid3D([9043,9149,9697,8271],0); -ELEMENTS[24699] = Fluid3D([8502,9469,9022,9039],0); -ELEMENTS[24700] = Fluid3D([9469,9043,9876,9919],0); -ELEMENTS[24701] = Fluid3D([9022,9469,9876,9882],0); -ELEMENTS[24702] = Fluid3D([9469,9876,9882,10818],0); -ELEMENTS[24703] = Fluid3D([9022,9469,9882,9039],0); -ELEMENTS[24704] = Fluid3D([9876,9022,9882,9708],0); -ELEMENTS[24705] = Fluid3D([9022,9882,9708,9203],0); -ELEMENTS[24706] = Fluid3D([9022,9882,9203,9039],0); -ELEMENTS[24707] = Fluid3D([9882,9708,9203,10359],0); -ELEMENTS[24708] = Fluid3D([9876,9022,9708,9149],0); -ELEMENTS[24709] = Fluid3D([9149,9876,9697,10057],0); -ELEMENTS[24710] = Fluid3D([9882,9876,9708,10818],0); -ELEMENTS[24711] = Fluid3D([9708,9022,9203,8764],0); -ELEMENTS[24712] = Fluid3D([9022,9203,8764,8491],0); -ELEMENTS[24713] = Fluid3D([9022,9203,8491,9039],0); -ELEMENTS[24714] = Fluid3D([9708,9022,8764,9149],0); -ELEMENTS[24715] = Fluid3D([9203,9708,8764,9901],0); -ELEMENTS[24716] = Fluid3D([10114,9972,10263,9361],0); -ELEMENTS[24717] = Fluid3D([9972,10263,9361,9556],0); -ELEMENTS[24718] = Fluid3D([10263,9361,9556,8678],0); -ELEMENTS[24719] = Fluid3D([10263,10114,9361,9475],0); -ELEMENTS[24720] = Fluid3D([9361,9972,9556,9201],0); -ELEMENTS[24721] = Fluid3D([9361,10263,9475,8678],0); -ELEMENTS[24722] = Fluid3D([10114,9972,9361,9633],0); -ELEMENTS[24723] = Fluid3D([9972,10263,9556,10558],0); -ELEMENTS[24724] = Fluid3D([9556,9972,10558,9904],0); -ELEMENTS[24725] = Fluid3D([10263,9556,10558,10007],0); -ELEMENTS[24726] = Fluid3D([7540,7407,7968,8054],0); -ELEMENTS[24727] = Fluid3D([8851,8772,8444,8022],0); -ELEMENTS[24728] = Fluid3D([10671,9944,10851,10874],0); -ELEMENTS[24729] = Fluid3D([6936,6390,7188,6978],0); -ELEMENTS[24730] = Fluid3D([3057,3501,3245,3256],0); -ELEMENTS[24731] = Fluid3D([3245,3057,3256,2924],0); -ELEMENTS[24732] = Fluid3D([3057,3501,3256,3583],0); -ELEMENTS[24733] = Fluid3D([3501,3256,3583,3639],0); -ELEMENTS[24734] = Fluid3D([3057,3256,2924,3197],0); -ELEMENTS[24735] = Fluid3D([3057,3256,3197,3583],0); -ELEMENTS[24736] = Fluid3D([3256,3197,3583,3638],0); -ELEMENTS[24737] = Fluid3D([3245,3057,2924,2943],0); -ELEMENTS[24738] = Fluid3D([3501,3245,3256,3639],0); -ELEMENTS[24739] = Fluid3D([3256,3245,2924,3158],0); -ELEMENTS[24740] = Fluid3D([16627,16660,16601,17158],0); -ELEMENTS[24741] = Fluid3D([6067,6178,5809,6590],0); -ELEMENTS[24742] = Fluid3D([7037,7362,7502,6808],0); -ELEMENTS[24743] = Fluid3D([7037,7362,6808,6522],0); -ELEMENTS[24744] = Fluid3D([7362,7502,6808,7373],0); -ELEMENTS[24745] = Fluid3D([7362,7502,7373,7936],0); -ELEMENTS[24746] = Fluid3D([6808,7362,7373,7275],0); -ELEMENTS[24747] = Fluid3D([7502,6808,7373,6816],0); -ELEMENTS[24748] = Fluid3D([7502,7037,6808,6581],0); -ELEMENTS[24749] = Fluid3D([13842,13088,13136,12754],0); -ELEMENTS[24750] = Fluid3D([16872,16820,16363,16563],0); -ELEMENTS[24751] = Fluid3D([16872,16820,16563,17171],0); -ELEMENTS[24752] = Fluid3D([16820,16363,16563,16313],0); -ELEMENTS[24753] = Fluid3D([16820,16363,16313,16624],0); -ELEMENTS[24754] = Fluid3D([16563,16820,16313,16541],0); -ELEMENTS[24755] = Fluid3D([16363,16872,16563,16199],0); -ELEMENTS[24756] = Fluid3D([16363,16563,16313,15943],0); -ELEMENTS[24757] = Fluid3D([16563,16313,15943,16454],0); -ELEMENTS[24758] = Fluid3D([10037,10886,10977,10442],0); -ELEMENTS[24759] = Fluid3D([10886,10977,10442,11481],0); -ELEMENTS[24760] = Fluid3D([10037,10886,10442,10621],0); -ELEMENTS[24761] = Fluid3D([10886,10442,10621,11481],0); -ELEMENTS[24762] = Fluid3D([10442,10621,11481,10210],0); -ELEMENTS[24763] = Fluid3D([10442,10621,10210,9564],0); -ELEMENTS[24764] = Fluid3D([10210,10442,9564,9517],0); -ELEMENTS[24765] = Fluid3D([10442,10621,9564,10037],0); -ELEMENTS[24766] = Fluid3D([10621,10886,11481,11762],0); -ELEMENTS[24767] = Fluid3D([9564,10442,10037,9809],0); -ELEMENTS[24768] = Fluid3D([9564,10442,9809,9517],0); -ELEMENTS[24769] = Fluid3D([9809,9564,9517,8649],0); -ELEMENTS[24770] = Fluid3D([10442,9809,9517,10361],0); -ELEMENTS[24771] = Fluid3D([10442,10037,9809,10977],0); -ELEMENTS[24772] = Fluid3D([10977,10442,11481,11070],0); -ELEMENTS[24773] = Fluid3D([11481,10977,11070,12220],0); -ELEMENTS[24774] = Fluid3D([10977,10442,11070,9809],0); -ELEMENTS[24775] = Fluid3D([10886,10977,11481,11737],0); -ELEMENTS[24776] = Fluid3D([10442,11481,11070,11148],0); -ELEMENTS[24777] = Fluid3D([12731,13331,12450,13000],0); -ELEMENTS[24778] = Fluid3D([3391,3237,3622,3281],0); -ELEMENTS[24779] = Fluid3D([3622,3391,3281,3741],0); -ELEMENTS[24780] = Fluid3D([3391,3237,3281,3081],0); -ELEMENTS[24781] = Fluid3D([3391,3237,3081,3206],0); -ELEMENTS[24782] = Fluid3D([3281,3391,3081,3201],0); -ELEMENTS[24783] = Fluid3D([3281,3391,3201,3741],0); -ELEMENTS[24784] = Fluid3D([3391,3081,3201,3260],0); -ELEMENTS[24785] = Fluid3D([3201,3391,3260,3741],0); -ELEMENTS[24786] = Fluid3D([3081,3201,3260,2952],0); -ELEMENTS[24787] = Fluid3D([3081,3201,2952,3281],0); -ELEMENTS[24788] = Fluid3D([3260,3201,3741,3473],0); -ELEMENTS[24789] = Fluid3D([3201,3741,3473,3281],0); -ELEMENTS[24790] = Fluid3D([3237,3622,3281,3133],0); -ELEMENTS[24791] = Fluid3D([3281,3237,3133,3081],0); -ELEMENTS[24792] = Fluid3D([3622,3281,3133,3462],0); -ELEMENTS[24793] = Fluid3D([14031,14440,13702,14998],0); -ELEMENTS[24794] = Fluid3D([8051,8225,7836,7517],0); -ELEMENTS[24795] = Fluid3D([8225,7836,7517,7614],0); -ELEMENTS[24796] = Fluid3D([7836,8051,7517,7329],0); -ELEMENTS[24797] = Fluid3D([8051,8225,7517,8090],0); -ELEMENTS[24798] = Fluid3D([7836,7517,7614,7010],0); -ELEMENTS[24799] = Fluid3D([7836,7517,7010,7329],0); -ELEMENTS[24800] = Fluid3D([7517,7614,7010,6527],0); -ELEMENTS[24801] = Fluid3D([7517,8225,7614,7647],0); -ELEMENTS[24802] = Fluid3D([8225,7614,7647,8615],0); -ELEMENTS[24803] = Fluid3D([7517,8225,7647,8090],0); -ELEMENTS[24804] = Fluid3D([7614,7517,7647,6527],0); -ELEMENTS[24805] = Fluid3D([8225,7836,7614,8891],0); -ELEMENTS[24806] = Fluid3D([7614,7836,7010,7538],0); -ELEMENTS[24807] = Fluid3D([7836,7010,7538,7556],0); -ELEMENTS[24808] = Fluid3D([7010,7538,7556,6749],0); -ELEMENTS[24809] = Fluid3D([7556,7010,6749,6664],0); -ELEMENTS[24810] = Fluid3D([6749,7556,6664,6659],0); -ELEMENTS[24811] = Fluid3D([7010,6749,6664,6298],0); -ELEMENTS[24812] = Fluid3D([7010,6749,6298,6638],0); -ELEMENTS[24813] = Fluid3D([7556,7010,6664,7329],0); -ELEMENTS[24814] = Fluid3D([7614,7836,7538,8891],0); -ELEMENTS[24815] = Fluid3D([6664,7010,6298,6516],0); -ELEMENTS[24816] = Fluid3D([7010,6298,6516,6527],0); -ELEMENTS[24817] = Fluid3D([7836,7010,7556,7329],0); -ELEMENTS[24818] = Fluid3D([7538,7836,7556,8692],0); -ELEMENTS[24819] = Fluid3D([7010,7614,7538,6638],0); -ELEMENTS[24820] = Fluid3D([7250,7613,7119,6332],0); -ELEMENTS[24821] = Fluid3D([7110,6524,6779,7608],0); -ELEMENTS[24822] = Fluid3D([13222,14109,13474,14201],0); -ELEMENTS[24823] = Fluid3D([10310,10014,10093,10752],0); -ELEMENTS[24824] = Fluid3D([10310,10014,10752,10723],0); -ELEMENTS[24825] = Fluid3D([10014,10752,10723,10753],0); -ELEMENTS[24826] = Fluid3D([10093,10310,10752,10867],0); -ELEMENTS[24827] = Fluid3D([10310,10752,10867,11716],0); -ELEMENTS[24828] = Fluid3D([10752,10093,10867,10556],0); -ELEMENTS[24829] = Fluid3D([10093,10310,10867,9513],0); -ELEMENTS[24830] = Fluid3D([10310,10014,10723,9702],0); -ELEMENTS[24831] = Fluid3D([10014,10093,10752,10556],0); -ELEMENTS[24832] = Fluid3D([10752,10310,10723,11348],0); -ELEMENTS[24833] = Fluid3D([10310,10723,11348,10767],0); -ELEMENTS[24834] = Fluid3D([10752,10310,11348,11716],0); -ELEMENTS[24835] = Fluid3D([10723,11348,10767,11954],0); -ELEMENTS[24836] = Fluid3D([11348,10767,11954,11594],0); -ELEMENTS[24837] = Fluid3D([11954,11348,11594,11716],0); -ELEMENTS[24838] = Fluid3D([11954,11348,11716,12419],0); -ELEMENTS[24839] = Fluid3D([11954,11348,12419,11666],0); -ELEMENTS[24840] = Fluid3D([11348,11594,11716,10310],0); -ELEMENTS[24841] = Fluid3D([10310,10723,10767,9702],0); -ELEMENTS[24842] = Fluid3D([11348,10310,10767,11594],0); -ELEMENTS[24843] = Fluid3D([10723,10752,11348,11666],0); -ELEMENTS[24844] = Fluid3D([10468,11172,11505,10497],0); -ELEMENTS[24845] = Fluid3D([11505,10468,10497,10517],0); -ELEMENTS[24846] = Fluid3D([7222,6941,7558,7721],0); -ELEMENTS[24847] = Fluid3D([6941,7558,7721,7584],0); -ELEMENTS[24848] = Fluid3D([7222,6941,7721,6688],0); -ELEMENTS[24849] = Fluid3D([7558,7222,7721,8366],0); -ELEMENTS[24850] = Fluid3D([12417,12089,13103,13272],0); -ELEMENTS[24851] = Fluid3D([14790,15241,15384,14618],0); -ELEMENTS[24852] = Fluid3D([8917,8804,9664,9433],0); -ELEMENTS[24853] = Fluid3D([9944,9665,9179,9126],0); -ELEMENTS[24854] = Fluid3D([9179,9944,9126,9506],0); -ELEMENTS[24855] = Fluid3D([13263,13415,13302,14033],0); -ELEMENTS[24856] = Fluid3D([7754,7443,7391,8195],0); -ELEMENTS[24857] = Fluid3D([7391,7754,8195,8318],0); -ELEMENTS[24858] = Fluid3D([7754,8195,8318,8684],0); -ELEMENTS[24859] = Fluid3D([7754,8195,8684,8257],0); -ELEMENTS[24860] = Fluid3D([7754,7443,8195,8257],0); -ELEMENTS[24861] = Fluid3D([8195,8684,8257,8745],0); -ELEMENTS[24862] = Fluid3D([8195,8318,8684,8991],0); -ELEMENTS[24863] = Fluid3D([8318,8684,8991,8672],0); -ELEMENTS[24864] = Fluid3D([8684,8195,8991,9261],0); -ELEMENTS[24865] = Fluid3D([8195,8318,8991,8218],0); -ELEMENTS[24866] = Fluid3D([8318,8991,8218,8721],0); -ELEMENTS[24867] = Fluid3D([8991,8218,8721,9417],0); -ELEMENTS[24868] = Fluid3D([8195,8318,8218,7391],0); -ELEMENTS[24869] = Fluid3D([8318,8991,8721,8672],0); -ELEMENTS[24870] = Fluid3D([8218,8318,8721,7851],0); -ELEMENTS[24871] = Fluid3D([8318,8721,7851,8222],0); -ELEMENTS[24872] = Fluid3D([8721,8218,7851,8441],0); -ELEMENTS[24873] = Fluid3D([8218,8318,7851,7391],0); -ELEMENTS[24874] = Fluid3D([8318,8721,8222,8672],0); -ELEMENTS[24875] = Fluid3D([8222,8318,8672,7622],0); -ELEMENTS[24876] = Fluid3D([7851,8318,8222,7424],0); -ELEMENTS[24877] = Fluid3D([8318,8222,7424,7622],0); -ELEMENTS[24878] = Fluid3D([8222,7851,7424,7492],0); -ELEMENTS[24879] = Fluid3D([7851,7424,7492,6969],0); -ELEMENTS[24880] = Fluid3D([7424,7492,6969,6706],0); -ELEMENTS[24881] = Fluid3D([7492,7851,6969,7609],0); -ELEMENTS[24882] = Fluid3D([6969,7492,7609,6750],0); -ELEMENTS[24883] = Fluid3D([7492,7851,7609,8247],0); -ELEMENTS[24884] = Fluid3D([7609,7492,8247,7725],0); -ELEMENTS[24885] = Fluid3D([7609,7492,7725,6750],0); -ELEMENTS[24886] = Fluid3D([7492,8247,7725,7826],0); -ELEMENTS[24887] = Fluid3D([8247,7609,7725,8556],0); -ELEMENTS[24888] = Fluid3D([7492,7851,8247,8222],0); -ELEMENTS[24889] = Fluid3D([8247,7492,8222,7826],0); -ELEMENTS[24890] = Fluid3D([7851,8247,8222,8721],0); -ELEMENTS[24891] = Fluid3D([7851,8318,7424,7391],0); -ELEMENTS[24892] = Fluid3D([7424,8222,7492,7622],0); -ELEMENTS[24893] = Fluid3D([8991,8195,8218,8645],0); -ELEMENTS[24894] = Fluid3D([8218,8991,8645,9417],0); -ELEMENTS[24895] = Fluid3D([8645,8218,9417,8441],0); -ELEMENTS[24896] = Fluid3D([8991,8645,9417,9261],0); -ELEMENTS[24897] = Fluid3D([9417,8991,9261,9911],0); -ELEMENTS[24898] = Fluid3D([9417,8991,9911,10109],0); -ELEMENTS[24899] = Fluid3D([9911,9417,10109,10407],0); -ELEMENTS[24900] = Fluid3D([10109,9911,10407,11118],0); -ELEMENTS[24901] = Fluid3D([8991,9261,9911,9323],0); -ELEMENTS[24902] = Fluid3D([8991,9261,9323,8684],0); -ELEMENTS[24903] = Fluid3D([9323,8991,8684,9316],0); -ELEMENTS[24904] = Fluid3D([8684,9323,9316,9274],0); -ELEMENTS[24905] = Fluid3D([8684,9323,9274,8895],0); -ELEMENTS[24906] = Fluid3D([8684,9323,8895,8745],0); -ELEMENTS[24907] = Fluid3D([9323,9274,8895,10474],0); -ELEMENTS[24908] = Fluid3D([9323,9316,9274,10432],0); -ELEMENTS[24909] = Fluid3D([9274,8684,8895,8373],0); -ELEMENTS[24910] = Fluid3D([9316,8684,9274,8859],0); -ELEMENTS[24911] = Fluid3D([8684,8895,8373,8257],0); -ELEMENTS[24912] = Fluid3D([8684,8895,8257,8745],0); -ELEMENTS[24913] = Fluid3D([9274,8684,8373,8859],0); -ELEMENTS[24914] = Fluid3D([9911,8991,9323,9316],0); -ELEMENTS[24915] = Fluid3D([8895,8373,8257,8294],0); -ELEMENTS[24916] = Fluid3D([8257,8895,8294,8299],0); -ELEMENTS[24917] = Fluid3D([8991,8684,9316,8672],0); -ELEMENTS[24918] = Fluid3D([8895,8257,8745,8299],0); -ELEMENTS[24919] = Fluid3D([8895,8373,8294,9488],0); -ELEMENTS[24920] = Fluid3D([9911,9417,10407,9261],0); -ELEMENTS[24921] = Fluid3D([8895,9274,8373,9488],0); -ELEMENTS[24922] = Fluid3D([9323,9911,9316,10432],0); -ELEMENTS[24923] = Fluid3D([9911,8991,9316,10109],0); -ELEMENTS[24924] = Fluid3D([7443,7391,8195,7639],0); -ELEMENTS[24925] = Fluid3D([7391,8195,7639,8218],0); -ELEMENTS[24926] = Fluid3D([7443,7391,7639,6766],0); -ELEMENTS[24927] = Fluid3D([8195,7443,7639,8351],0); -ELEMENTS[24928] = Fluid3D([8684,7754,8257,8373],0); -ELEMENTS[24929] = Fluid3D([7391,7754,8318,7215],0); -ELEMENTS[24930] = Fluid3D([8318,7754,8684,8029],0); -ELEMENTS[24931] = Fluid3D([15336,15092,15007,14565],0); -ELEMENTS[24932] = Fluid3D([6055,6824,6605,6421],0); -ELEMENTS[24933] = Fluid3D([6824,6605,6421,7225],0); -ELEMENTS[24934] = Fluid3D([6055,6824,6421,5801],0); -ELEMENTS[24935] = Fluid3D([6605,6421,7225,6604],0); -ELEMENTS[24936] = Fluid3D([7225,6605,6604,6923],0); -ELEMENTS[24937] = Fluid3D([6605,6604,6923,6225],0); -ELEMENTS[24938] = Fluid3D([6605,6604,6225,6421],0); -ELEMENTS[24939] = Fluid3D([6923,6605,6225,6810],0); -ELEMENTS[24940] = Fluid3D([6605,6055,6421,6225],0); -ELEMENTS[24941] = Fluid3D([6605,6055,6225,5926],0); -ELEMENTS[24942] = Fluid3D([6225,6605,5926,6810],0); -ELEMENTS[24943] = Fluid3D([6824,6605,7225,7728],0); -ELEMENTS[24944] = Fluid3D([6421,6824,7225,7198],0); -ELEMENTS[24945] = Fluid3D([10457,10365,10714,11336],0); -ELEMENTS[24946] = Fluid3D([16810,16511,17003,16695],0); -ELEMENTS[24947] = Fluid3D([14434,14752,14046,14878],0); -ELEMENTS[24948] = Fluid3D([17447,17408,17056,17358],0); -ELEMENTS[24949] = Fluid3D([17056,17447,17358,17164],0); -ELEMENTS[24950] = Fluid3D([17408,17056,17358,17328],0); -ELEMENTS[24951] = Fluid3D([17358,17408,17328,17537],0); -ELEMENTS[24952] = Fluid3D([17447,17408,17358,17786],0); -ELEMENTS[24953] = Fluid3D([17358,17447,17786,17569],0); -ELEMENTS[24954] = Fluid3D([17447,17786,17569,17802],0); -ELEMENTS[24955] = Fluid3D([17447,17408,17786,17594],0); -ELEMENTS[24956] = Fluid3D([17358,17447,17569,17164],0); -ELEMENTS[24957] = Fluid3D([17786,17358,17569,17673],0); -ELEMENTS[24958] = Fluid3D([17358,17569,17673,17419],0); -ELEMENTS[24959] = Fluid3D([17786,17358,17673,17537],0); -ELEMENTS[24960] = Fluid3D([17673,17358,17419,17282],0); -ELEMENTS[24961] = Fluid3D([17358,17419,17282,17164],0); -ELEMENTS[24962] = Fluid3D([17673,17358,17282,17537],0); -ELEMENTS[24963] = Fluid3D([17419,17673,17282,17341],0); -ELEMENTS[24964] = Fluid3D([17282,17673,17537,17484],0); -ELEMENTS[24965] = Fluid3D([17358,17282,17537,17328],0); -ELEMENTS[24966] = Fluid3D([17358,17282,17328,17056],0); -ELEMENTS[24967] = Fluid3D([17282,17537,17328,17076],0); -ELEMENTS[24968] = Fluid3D([17282,17419,17341,16980],0); -ELEMENTS[24969] = Fluid3D([17569,17786,17673,17944],0); -ELEMENTS[24970] = Fluid3D([17673,17569,17944,17827],0); -ELEMENTS[24971] = Fluid3D([17944,17673,17827,17977],0); -ELEMENTS[24972] = Fluid3D([17944,17673,17977,17908],0); -ELEMENTS[24973] = Fluid3D([17944,17673,17908,17786],0); -ELEMENTS[24974] = Fluid3D([17977,17944,17908,18236],0); -ELEMENTS[24975] = Fluid3D([17569,17786,17944,17802],0); -ELEMENTS[24976] = Fluid3D([17673,17569,17827,17419],0); -ELEMENTS[24977] = Fluid3D([17827,17944,17977,18133],0); -ELEMENTS[24978] = Fluid3D([17944,17977,18133,18261],0); -ELEMENTS[24979] = Fluid3D([17827,17944,18133,17963],0); -ELEMENTS[24980] = Fluid3D([18133,17827,17963,18018],0); -ELEMENTS[24981] = Fluid3D([18133,17827,18018,17895],0); -ELEMENTS[24982] = Fluid3D([17827,17944,17963,17569],0); -ELEMENTS[24983] = Fluid3D([17977,17827,18133,17895],0); -ELEMENTS[24984] = Fluid3D([17944,18133,17963,18179],0); -ELEMENTS[24985] = Fluid3D([18133,17963,18179,18216],0); -ELEMENTS[24986] = Fluid3D([17944,18133,18179,18236],0); -ELEMENTS[24987] = Fluid3D([17963,17944,18179,17802],0); -ELEMENTS[24988] = Fluid3D([18133,17963,18216,18018],0); -ELEMENTS[24989] = Fluid3D([17963,18179,18216,18128],0); -ELEMENTS[24990] = Fluid3D([18216,17963,18128,18042],0); -ELEMENTS[24991] = Fluid3D([18179,18216,18128,18346],0); -ELEMENTS[24992] = Fluid3D([18216,18128,18346,18281],0); -ELEMENTS[24993] = Fluid3D([18216,18128,18281,18042],0); -ELEMENTS[24994] = Fluid3D([18179,18216,18346,18381],0); -ELEMENTS[24995] = Fluid3D([17963,18179,18128,17802],0); -ELEMENTS[24996] = Fluid3D([18216,17963,18042,18018],0); -ELEMENTS[24997] = Fluid3D([17963,18128,18042,17842],0); -ELEMENTS[24998] = Fluid3D([18128,18042,17842,18058],0); -ELEMENTS[24999] = Fluid3D([17842,18128,18058,17982],0); -ELEMENTS[25000] = Fluid3D([17842,18128,17982,17802],0); -ELEMENTS[25001] = Fluid3D([18042,17963,17842,17728],0); -ELEMENTS[25002] = Fluid3D([18042,17963,17728,18018],0); -ELEMENTS[25003] = Fluid3D([17963,17842,17728,17569],0); -ELEMENTS[25004] = Fluid3D([17963,18128,17842,17802],0); -ELEMENTS[25005] = Fluid3D([18042,17842,18058,17826],0); -ELEMENTS[25006] = Fluid3D([18042,17842,17826,17728],0); -ELEMENTS[25007] = Fluid3D([18058,18042,17826,18135],0); -ELEMENTS[25008] = Fluid3D([18042,17826,18135,17955],0); -ELEMENTS[25009] = Fluid3D([18042,17826,17955,17728],0); -ELEMENTS[25010] = Fluid3D([18058,18042,18135,18281],0); -ELEMENTS[25011] = Fluid3D([17842,18058,17826,17764],0); -ELEMENTS[25012] = Fluid3D([17826,17842,17764,17520],0); -ELEMENTS[25013] = Fluid3D([17764,17826,17520,17485],0); -ELEMENTS[25014] = Fluid3D([17842,18058,17764,17982],0); -ELEMENTS[25015] = Fluid3D([17826,17842,17520,17728],0); -ELEMENTS[25016] = Fluid3D([18058,17826,17764,17935],0); -ELEMENTS[25017] = Fluid3D([17826,17764,17935,17485],0); -ELEMENTS[25018] = Fluid3D([18058,17826,17935,18135],0); -ELEMENTS[25019] = Fluid3D([17764,18058,17935,18023],0); -ELEMENTS[25020] = Fluid3D([18058,17935,18023,18265],0); -ELEMENTS[25021] = Fluid3D([17764,18058,18023,17982],0); -ELEMENTS[25022] = Fluid3D([17935,17764,18023,17756],0); -ELEMENTS[25023] = Fluid3D([18023,17935,17756,18089],0); -ELEMENTS[25024] = Fluid3D([17756,18023,18089,18071],0); -ELEMENTS[25025] = Fluid3D([18023,17935,18089,18265],0); -ELEMENTS[25026] = Fluid3D([17935,17764,17756,17485],0); -ELEMENTS[25027] = Fluid3D([17764,18023,17756,17652],0); -ELEMENTS[25028] = Fluid3D([17756,17764,17652,17497],0); -ELEMENTS[25029] = Fluid3D([17764,17652,17497,17530],0); -ELEMENTS[25030] = Fluid3D([17756,17764,17497,17485],0); -ELEMENTS[25031] = Fluid3D([18089,18023,18265,18245],0); -ELEMENTS[25032] = Fluid3D([18089,18023,18245,18071],0); -ELEMENTS[25033] = Fluid3D([18128,18042,18058,18281],0); -ELEMENTS[25034] = Fluid3D([17827,17963,18018,17728],0); -ELEMENTS[25035] = Fluid3D([17673,17827,17977,17715],0); -ELEMENTS[25036] = Fluid3D([17977,17673,17715,17908],0); -ELEMENTS[25037] = Fluid3D([18128,18346,18281,18254],0); -ELEMENTS[25038] = Fluid3D([18281,18128,18254,18058],0); -ELEMENTS[25039] = Fluid3D([18346,18281,18254,18500],0); -ELEMENTS[25040] = Fluid3D([18128,18346,18254,18309],0); -ELEMENTS[25041] = Fluid3D([18254,18128,18309,17982],0); -ELEMENTS[25042] = Fluid3D([18346,18254,18309,18490],0); -ELEMENTS[25043] = Fluid3D([18128,18346,18309,18179],0); -ELEMENTS[25044] = Fluid3D([18128,18058,17982,18254],0); -ELEMENTS[25045] = Fluid3D([17408,17358,17786,17537],0); -ELEMENTS[25046] = Fluid3D([17358,17569,17419,17164],0); -ELEMENTS[25047] = Fluid3D([18179,18133,18216,18381],0); -ELEMENTS[25048] = Fluid3D([18135,18042,17955,18202],0); -ELEMENTS[25049] = Fluid3D([18042,17955,18202,18018],0); -ELEMENTS[25050] = Fluid3D([18135,18042,18202,18281],0); -ELEMENTS[25051] = Fluid3D([17955,18135,18202,18138],0); -ELEMENTS[25052] = Fluid3D([18135,18202,18138,18286],0); -ELEMENTS[25053] = Fluid3D([17955,18135,18138,17872],0); -ELEMENTS[25054] = Fluid3D([18138,17955,17872,17873],0); -ELEMENTS[25055] = Fluid3D([17872,18138,17873,18019],0); -ELEMENTS[25056] = Fluid3D([17873,17872,18019,17741],0); -ELEMENTS[25057] = Fluid3D([17873,17872,17741,17415],0); -ELEMENTS[25058] = Fluid3D([17955,18135,17872,17826],0); -ELEMENTS[25059] = Fluid3D([17872,18138,18019,18147],0); -ELEMENTS[25060] = Fluid3D([18019,17873,17741,17739],0); -ELEMENTS[25061] = Fluid3D([18138,17955,17873,18074],0); -ELEMENTS[25062] = Fluid3D([17955,17873,18074,17768],0); -ELEMENTS[25063] = Fluid3D([17873,18074,17768,17692],0); -ELEMENTS[25064] = Fluid3D([18138,17955,18074,18202],0); -ELEMENTS[25065] = Fluid3D([17873,18138,18074,18108],0); -ELEMENTS[25066] = Fluid3D([18074,17955,17768,17964],0); -ELEMENTS[25067] = Fluid3D([17768,18074,17964,17952],0); -ELEMENTS[25068] = Fluid3D([17955,17768,17964,17711],0); -ELEMENTS[25069] = Fluid3D([17964,17955,17711,17728],0); -ELEMENTS[25070] = Fluid3D([17955,17711,17728,17603],0); -ELEMENTS[25071] = Fluid3D([17711,17728,17603,17380],0); -ELEMENTS[25072] = Fluid3D([17711,17728,17380,17625],0); -ELEMENTS[25073] = Fluid3D([17711,17728,17625,17964],0); -ELEMENTS[25074] = Fluid3D([17380,17711,17625,17437],0); -ELEMENTS[25075] = Fluid3D([17603,17711,17380,17437],0); -ELEMENTS[25076] = Fluid3D([17728,17380,17625,17569],0); -ELEMENTS[25077] = Fluid3D([17711,17625,17437,17795],0); -ELEMENTS[25078] = Fluid3D([17711,17625,17795,17964],0); -ELEMENTS[25079] = Fluid3D([17795,17711,17964,17768],0); -ELEMENTS[25080] = Fluid3D([17964,17795,17768,17952],0); -ELEMENTS[25081] = Fluid3D([17964,17795,17952,18031],0); -ELEMENTS[25082] = Fluid3D([17964,17795,18031,18018],0); -ELEMENTS[25083] = Fluid3D([17964,17795,18018,17625],0); -ELEMENTS[25084] = Fluid3D([18031,17964,18018,18228],0); -ELEMENTS[25085] = Fluid3D([17964,18018,18228,18202],0); -ELEMENTS[25086] = Fluid3D([17728,17603,17380,17520],0); -ELEMENTS[25087] = Fluid3D([18031,17964,18228,17952],0); -ELEMENTS[25088] = Fluid3D([17437,17711,17795,17768],0); -ELEMENTS[25089] = Fluid3D([17603,17380,17520,17174],0); -ELEMENTS[25090] = Fluid3D([17795,18031,18018,17895],0); -ELEMENTS[25091] = Fluid3D([18018,18031,18228,18195],0); -ELEMENTS[25092] = Fluid3D([18228,18018,18195,18216],0); -ELEMENTS[25093] = Fluid3D([17955,17711,17603,17768],0); -ELEMENTS[25094] = Fluid3D([17625,17437,17795,17565],0); -ELEMENTS[25095] = Fluid3D([18018,18031,18195,17895],0); -ELEMENTS[25096] = Fluid3D([17728,17603,17520,17826],0); -ELEMENTS[25097] = Fluid3D([17603,17520,17826,17485],0); -ELEMENTS[25098] = Fluid3D([17728,17603,17826,17955],0); -ELEMENTS[25099] = Fluid3D([17603,17826,17955,17872],0); -ELEMENTS[25100] = Fluid3D([17625,17380,17437,17164],0); -ELEMENTS[25101] = Fluid3D([17795,17952,18031,17868],0); -ELEMENTS[25102] = Fluid3D([18074,17955,17964,18202],0); -ELEMENTS[25103] = Fluid3D([17768,18074,17952,17692],0); -ELEMENTS[25104] = Fluid3D([17955,17873,17768,17603],0); -ELEMENTS[25105] = Fluid3D([17872,18019,17741,17699],0); -ELEMENTS[25106] = Fluid3D([17741,17872,17699,17415],0); -ELEMENTS[25107] = Fluid3D([17699,17741,17415,17758],0); -ELEMENTS[25108] = Fluid3D([17699,17741,17758,18019],0); -ELEMENTS[25109] = Fluid3D([17955,17872,17873,17603],0); -ELEMENTS[25110] = Fluid3D([18135,18138,17872,18147],0); -ELEMENTS[25111] = Fluid3D([18074,17964,17952,18228],0); -ELEMENTS[25112] = Fluid3D([18138,17873,18019,18108],0); -ELEMENTS[25113] = Fluid3D([18346,18216,18281,18423],0); -ELEMENTS[25114] = Fluid3D([18216,18281,18423,18202],0); -ELEMENTS[25115] = Fluid3D([18346,18216,18423,18381],0); -ELEMENTS[25116] = Fluid3D([18281,18346,18423,18500],0); -ELEMENTS[25117] = Fluid3D([17842,17764,17520,17530],0); -ELEMENTS[25118] = Fluid3D([3619,3667,3263,3565],0); -ELEMENTS[25119] = Fluid3D([3667,3263,3565,3396],0); -ELEMENTS[25120] = Fluid3D([3619,3667,3565,4097],0); -ELEMENTS[25121] = Fluid3D([3263,3565,3396,3148],0); -ELEMENTS[25122] = Fluid3D([3396,3263,3148,2998],0); -ELEMENTS[25123] = Fluid3D([3263,3619,3565,3295],0); -ELEMENTS[25124] = Fluid3D([3148,3396,2998,3290],0); -ELEMENTS[25125] = Fluid3D([3148,3396,3290,3565],0); -ELEMENTS[25126] = Fluid3D([3263,3619,3295,3229],0); -ELEMENTS[25127] = Fluid3D([3295,3263,3229,2892],0); -ELEMENTS[25128] = Fluid3D([3263,3619,3229,3471],0); -ELEMENTS[25129] = Fluid3D([3396,3263,2998,3361],0); -ELEMENTS[25130] = Fluid3D([3263,3565,3148,3295],0); -ELEMENTS[25131] = Fluid3D([3667,3263,3396,3361],0); -ELEMENTS[25132] = Fluid3D([3619,3565,3295,3727],0); -ELEMENTS[25133] = Fluid3D([3619,3565,3727,4097],0); -ELEMENTS[25134] = Fluid3D([3565,3295,3727,3719],0); -ELEMENTS[25135] = Fluid3D([3295,3619,3727,3605],0); -ELEMENTS[25136] = Fluid3D([3619,3295,3229,3640],0); -ELEMENTS[25137] = Fluid3D([3565,3667,3396,3681],0); -ELEMENTS[25138] = Fluid3D([3263,3148,2998,2892],0); -ELEMENTS[25139] = Fluid3D([11810,11256,12203,11888],0); -ELEMENTS[25140] = Fluid3D([9376,8723,9262,9679],0); -ELEMENTS[25141] = Fluid3D([8723,9262,9679,9080],0); -ELEMENTS[25142] = Fluid3D([9262,9679,9080,9884],0); -ELEMENTS[25143] = Fluid3D([9262,9376,9679,10326],0); -ELEMENTS[25144] = Fluid3D([9679,9262,10326,9884],0); -ELEMENTS[25145] = Fluid3D([9262,9376,10326,9414],0); -ELEMENTS[25146] = Fluid3D([9376,8723,9679,9507],0); -ELEMENTS[25147] = Fluid3D([8723,9262,9080,7895],0); -ELEMENTS[25148] = Fluid3D([9679,8723,9080,9188],0); -ELEMENTS[25149] = Fluid3D([9376,9679,10326,10490],0); -ELEMENTS[25150] = Fluid3D([12806,12510,13428,12610],0); -ELEMENTS[25151] = Fluid3D([5164,5158,4669,5461],0); -ELEMENTS[25152] = Fluid3D([17280,17454,17609,17576],0); -ELEMENTS[25153] = Fluid3D([7333,8187,8333,7569],0); -ELEMENTS[25154] = Fluid3D([5807,5864,5854,6580],0); -ELEMENTS[25155] = Fluid3D([4620,4637,4958,4428],0); -ELEMENTS[25156] = Fluid3D([16098,15683,16151,16338],0); -ELEMENTS[25157] = Fluid3D([8774,8007,7871,8411],0); -ELEMENTS[25158] = Fluid3D([15327,15467,14886,15666],0); -ELEMENTS[25159] = Fluid3D([11529,12176,12497,11977],0); -ELEMENTS[25160] = Fluid3D([13711,13742,13297,14382],0); -ELEMENTS[25161] = Fluid3D([16845,17198,17131,17384],0); -ELEMENTS[25162] = Fluid3D([4585,4914,4827,5223],0); -ELEMENTS[25163] = Fluid3D([2432,2536,2275,2527],0); -ELEMENTS[25164] = Fluid3D([2536,2275,2527,2485],0); -ELEMENTS[25165] = Fluid3D([2432,2536,2527,2794],0); -ELEMENTS[25166] = Fluid3D([2275,2432,2527,2290],0); -ELEMENTS[25167] = Fluid3D([2527,2275,2290,2292],0); -ELEMENTS[25168] = Fluid3D([2275,2290,2292,2098],0); -ELEMENTS[25169] = Fluid3D([2275,2290,2098,2171],0); -ELEMENTS[25170] = Fluid3D([2275,2432,2290,2171],0); -ELEMENTS[25171] = Fluid3D([2290,2292,2098,2178],0); -ELEMENTS[25172] = Fluid3D([2098,2290,2178,2087],0); -ELEMENTS[25173] = Fluid3D([2290,2178,2087,2271],0); -ELEMENTS[25174] = Fluid3D([2290,2178,2271,2440],0); -ELEMENTS[25175] = Fluid3D([2290,2178,2440,2292],0); -ELEMENTS[25176] = Fluid3D([2178,2271,2440,2287],0); -ELEMENTS[25177] = Fluid3D([2271,2440,2287,2520],0); -ELEMENTS[25178] = Fluid3D([2271,2440,2520,2537],0); -ELEMENTS[25179] = Fluid3D([2440,2520,2537,2779],0); -ELEMENTS[25180] = Fluid3D([2440,2520,2779,2588],0); -ELEMENTS[25181] = Fluid3D([2440,2520,2588,2287],0); -ELEMENTS[25182] = Fluid3D([2178,2271,2287,2086],0); -ELEMENTS[25183] = Fluid3D([2287,2178,2086,2096],0); -ELEMENTS[25184] = Fluid3D([2287,2178,2096,2338],0); -ELEMENTS[25185] = Fluid3D([2178,2096,2338,2056],0); -ELEMENTS[25186] = Fluid3D([2178,2096,2056,1975],0); -ELEMENTS[25187] = Fluid3D([2178,2096,1975,2086],0); -ELEMENTS[25188] = Fluid3D([2287,2178,2338,2440],0); -ELEMENTS[25189] = Fluid3D([2178,2271,2086,2087],0); -ELEMENTS[25190] = Fluid3D([2271,2440,2537,2290],0); -ELEMENTS[25191] = Fluid3D([2520,2779,2588,2876],0); -ELEMENTS[25192] = Fluid3D([2588,2520,2876,2500],0); -ELEMENTS[25193] = Fluid3D([2520,2876,2500,2833],0); -ELEMENTS[25194] = Fluid3D([2520,2876,2833,2779],0); -ELEMENTS[25195] = Fluid3D([2876,2500,2833,2767],0); -ELEMENTS[25196] = Fluid3D([2833,2876,2767,3139],0); -ELEMENTS[25197] = Fluid3D([2833,2876,3139,3234],0); -ELEMENTS[25198] = Fluid3D([2500,2520,2833,2563],0); -ELEMENTS[25199] = Fluid3D([2500,2520,2563,2266],0); -ELEMENTS[25200] = Fluid3D([2500,2520,2266,2287],0); -ELEMENTS[25201] = Fluid3D([2500,2520,2287,2588],0); -ELEMENTS[25202] = Fluid3D([2779,2588,2876,2926],0); -ELEMENTS[25203] = Fluid3D([2779,2588,2926,2639],0); -ELEMENTS[25204] = Fluid3D([2779,2588,2639,2440],0); -ELEMENTS[25205] = Fluid3D([2876,2779,2926,3062],0); -ELEMENTS[25206] = Fluid3D([2588,2876,2926,2811],0); -ELEMENTS[25207] = Fluid3D([2588,2876,2811,2767],0); -ELEMENTS[25208] = Fluid3D([2876,2811,2767,3139],0); -ELEMENTS[25209] = Fluid3D([2926,2588,2811,2648],0); -ELEMENTS[25210] = Fluid3D([2876,2926,2811,3126],0); -ELEMENTS[25211] = Fluid3D([2926,2588,2648,2639],0); -ELEMENTS[25212] = Fluid3D([2876,2926,3126,3339],0); -ELEMENTS[25213] = Fluid3D([2811,2926,2648,3080],0); -ELEMENTS[25214] = Fluid3D([2926,2648,3080,3053],0); -ELEMENTS[25215] = Fluid3D([2811,2926,3080,3126],0); -ELEMENTS[25216] = Fluid3D([2588,2811,2648,2486],0); -ELEMENTS[25217] = Fluid3D([2588,2811,2486,2544],0); -ELEMENTS[25218] = Fluid3D([2648,2588,2486,2338],0); -ELEMENTS[25219] = Fluid3D([2811,2486,2544,2709],0); -ELEMENTS[25220] = Fluid3D([2811,2648,2486,2734],0); -ELEMENTS[25221] = Fluid3D([2486,2811,2734,2709],0); -ELEMENTS[25222] = Fluid3D([2811,2648,2734,3080],0); -ELEMENTS[25223] = Fluid3D([2648,2486,2734,2524],0); -ELEMENTS[25224] = Fluid3D([2486,2734,2524,2439],0); -ELEMENTS[25225] = Fluid3D([2648,2486,2524,2441],0); -ELEMENTS[25226] = Fluid3D([2648,2486,2441,2338],0); -ELEMENTS[25227] = Fluid3D([2486,2524,2441,2341],0); -ELEMENTS[25228] = Fluid3D([2486,2524,2341,2439],0); -ELEMENTS[25229] = Fluid3D([2524,2441,2341,2354],0); -ELEMENTS[25230] = Fluid3D([2524,2648,2441,2354],0); -ELEMENTS[25231] = Fluid3D([2441,2341,2354,2338],0); -ELEMENTS[25232] = Fluid3D([2441,2341,2338,2486],0); -ELEMENTS[25233] = Fluid3D([2354,2441,2338,2416],0); -ELEMENTS[25234] = Fluid3D([2441,2338,2416,2531],0); -ELEMENTS[25235] = Fluid3D([2416,2441,2531,2648],0); -ELEMENTS[25236] = Fluid3D([2441,2338,2531,2639],0); -ELEMENTS[25237] = Fluid3D([2338,2416,2531,2292],0); -ELEMENTS[25238] = Fluid3D([2531,2441,2639,2648],0); -ELEMENTS[25239] = Fluid3D([2354,2441,2416,2648],0); -ELEMENTS[25240] = Fluid3D([2416,2531,2292,2483],0); -ELEMENTS[25241] = Fluid3D([2416,2531,2483,2775],0); -ELEMENTS[25242] = Fluid3D([2416,2531,2775,2648],0); -ELEMENTS[25243] = Fluid3D([2531,2483,2775,2805],0); -ELEMENTS[25244] = Fluid3D([2775,2531,2805,2639],0); -ELEMENTS[25245] = Fluid3D([2531,2805,2639,2527],0); -ELEMENTS[25246] = Fluid3D([2775,2531,2639,2648],0); -ELEMENTS[25247] = Fluid3D([2531,2483,2805,2527],0); -ELEMENTS[25248] = Fluid3D([2483,2416,2775,2444],0); -ELEMENTS[25249] = Fluid3D([2416,2775,2444,2542],0); -ELEMENTS[25250] = Fluid3D([2416,2775,2542,2648],0); -ELEMENTS[25251] = Fluid3D([2444,2416,2542,2259],0); -ELEMENTS[25252] = Fluid3D([2416,2542,2259,2354],0); -ELEMENTS[25253] = Fluid3D([2542,2259,2354,2280],0); -ELEMENTS[25254] = Fluid3D([2259,2354,2280,2099],0); -ELEMENTS[25255] = Fluid3D([2259,2354,2099,2194],0); -ELEMENTS[25256] = Fluid3D([2099,2259,2194,2163],0); -ELEMENTS[25257] = Fluid3D([2099,2259,2163,2123],0); -ELEMENTS[25258] = Fluid3D([2259,2354,2194,2416],0); -ELEMENTS[25259] = Fluid3D([2280,2259,2099,2123],0); -ELEMENTS[25260] = Fluid3D([2259,2194,2163,2416],0); -ELEMENTS[25261] = Fluid3D([2194,2099,2163,1942],0); -ELEMENTS[25262] = Fluid3D([2483,2416,2444,2163],0); -ELEMENTS[25263] = Fluid3D([2444,2416,2259,2163],0); -ELEMENTS[25264] = Fluid3D([2775,2444,2542,2714],0); -ELEMENTS[25265] = Fluid3D([2542,2775,2714,2914],0); -ELEMENTS[25266] = Fluid3D([2775,2444,2714,2652],0); -ELEMENTS[25267] = Fluid3D([2775,2444,2652,2483],0); -ELEMENTS[25268] = Fluid3D([2714,2775,2652,3124],0); -ELEMENTS[25269] = Fluid3D([2542,2444,2259,2402],0); -ELEMENTS[25270] = Fluid3D([2444,2259,2402,2196],0); -ELEMENTS[25271] = Fluid3D([2444,2259,2196,2163],0); -ELEMENTS[25272] = Fluid3D([2259,2196,2163,2123],0); -ELEMENTS[25273] = Fluid3D([2259,2196,2123,2402],0); -ELEMENTS[25274] = Fluid3D([2196,2123,2402,2281],0); -ELEMENTS[25275] = Fluid3D([2196,2123,2281,1992],0); -ELEMENTS[25276] = Fluid3D([2402,2196,2281,2455],0); -ELEMENTS[25277] = Fluid3D([2196,2281,2455,2239],0); -ELEMENTS[25278] = Fluid3D([2196,2281,2239,1992],0); -ELEMENTS[25279] = Fluid3D([2455,2196,2239,2298],0); -ELEMENTS[25280] = Fluid3D([2455,2196,2298,2444],0); -ELEMENTS[25281] = Fluid3D([2298,2455,2444,2652],0); -ELEMENTS[25282] = Fluid3D([2455,2196,2444,2402],0); -ELEMENTS[25283] = Fluid3D([2444,2455,2402,2714],0); -ELEMENTS[25284] = Fluid3D([2444,2455,2714,2652],0); -ELEMENTS[25285] = Fluid3D([2196,2298,2444,2163],0); -ELEMENTS[25286] = Fluid3D([2196,2239,2298,2071],0); -ELEMENTS[25287] = Fluid3D([2196,2239,2071,1992],0); -ELEMENTS[25288] = Fluid3D([2281,2455,2239,2426],0); -ELEMENTS[25289] = Fluid3D([2239,2298,2071,2199],0); -ELEMENTS[25290] = Fluid3D([2071,2239,2199,2047],0); -ELEMENTS[25291] = Fluid3D([2071,2239,2047,1992],0); -ELEMENTS[25292] = Fluid3D([2281,2455,2426,2567],0); -ELEMENTS[25293] = Fluid3D([2426,2281,2567,2366],0); -ELEMENTS[25294] = Fluid3D([2239,2298,2199,2451],0); -ELEMENTS[25295] = Fluid3D([2281,2455,2567,2402],0); -ELEMENTS[25296] = Fluid3D([2239,2281,2426,2226],0); -ELEMENTS[25297] = Fluid3D([2239,2281,2226,1992],0); -ELEMENTS[25298] = Fluid3D([2281,2426,2226,2366],0); -ELEMENTS[25299] = Fluid3D([2426,2239,2226,2301],0); -ELEMENTS[25300] = Fluid3D([2239,2226,2301,2047],0); -ELEMENTS[25301] = Fluid3D([2426,2239,2301,2451],0); -ELEMENTS[25302] = Fluid3D([2298,2196,2071,2163],0); -ELEMENTS[25303] = Fluid3D([2196,2071,2163,1967],0); -ELEMENTS[25304] = Fluid3D([2259,2542,2402,2280],0); -ELEMENTS[25305] = Fluid3D([2402,2259,2280,2123],0); -ELEMENTS[25306] = Fluid3D([2239,2199,2047,2301],0); -ELEMENTS[25307] = Fluid3D([2542,2444,2402,2714],0); -ELEMENTS[25308] = Fluid3D([2483,2775,2805,2652],0); -ELEMENTS[25309] = Fluid3D([2455,2239,2426,2451],0); -ELEMENTS[25310] = Fluid3D([2298,2199,2451,2389],0); -ELEMENTS[25311] = Fluid3D([2451,2298,2389,2652],0); -ELEMENTS[25312] = Fluid3D([2199,2451,2389,2381],0); -ELEMENTS[25313] = Fluid3D([2199,2451,2381,2301],0); -ELEMENTS[25314] = Fluid3D([2389,2199,2381,2223],0); -ELEMENTS[25315] = Fluid3D([2389,2199,2223,2298],0); -ELEMENTS[25316] = Fluid3D([2381,2389,2223,2495],0); -ELEMENTS[25317] = Fluid3D([2389,2223,2495,2485],0); -ELEMENTS[25318] = Fluid3D([2495,2389,2485,2749],0); -ELEMENTS[25319] = Fluid3D([2381,2389,2495,2749],0); -ELEMENTS[25320] = Fluid3D([2389,2223,2485,2298],0); -ELEMENTS[25321] = Fluid3D([2451,2389,2381,2749],0); -ELEMENTS[25322] = Fluid3D([2734,2648,2524,2844],0); -ELEMENTS[25323] = Fluid3D([2096,2056,1975,1928],0); -ELEMENTS[25324] = Fluid3D([1975,2096,1928,2086],0); -ELEMENTS[25325] = Fluid3D([2298,2071,2199,2141],0); -ELEMENTS[25326] = Fluid3D([2071,2199,2141,2018],0); -ELEMENTS[25327] = Fluid3D([2298,2071,2141,2163],0); -ELEMENTS[25328] = Fluid3D([2199,2298,2141,2223],0); -ELEMENTS[25329] = Fluid3D([2141,2199,2223,2018],0); -ELEMENTS[25330] = Fluid3D([2588,2811,2544,2767],0); -ELEMENTS[25331] = Fluid3D([2811,2544,2767,2709],0); -ELEMENTS[25332] = Fluid3D([2292,2098,2178,2056],0); -ELEMENTS[25333] = Fluid3D([2096,2338,2056,2074],0); -ELEMENTS[25334] = Fluid3D([2455,2426,2567,2733],0); -ELEMENTS[25335] = Fluid3D([2426,2567,2733,2703],0); -ELEMENTS[25336] = Fluid3D([2567,2733,2703,2898],0); -ELEMENTS[25337] = Fluid3D([2733,2703,2898,3008],0); -ELEMENTS[25338] = Fluid3D([2898,2733,3008,3117],0); -ELEMENTS[25339] = Fluid3D([2898,2733,3117,2714],0); -ELEMENTS[25340] = Fluid3D([2455,2426,2733,2451],0); -ELEMENTS[25341] = Fluid3D([2733,2703,3008,2735],0); -ELEMENTS[25342] = Fluid3D([3008,2733,2735,2911],0); -ELEMENTS[25343] = Fluid3D([2703,3008,2735,2959],0); -ELEMENTS[25344] = Fluid3D([2703,3008,2959,3189],0); -ELEMENTS[25345] = Fluid3D([2733,2703,2735,2426],0); -ELEMENTS[25346] = Fluid3D([3008,2735,2959,3197],0); -ELEMENTS[25347] = Fluid3D([2959,3008,3197,3189],0); -ELEMENTS[25348] = Fluid3D([3008,2733,2911,3117],0); -ELEMENTS[25349] = Fluid3D([2567,2455,2733,2714],0); -ELEMENTS[25350] = Fluid3D([2426,2567,2703,2366],0); -ELEMENTS[25351] = Fluid3D([2567,2733,2898,2714],0); -ELEMENTS[25352] = Fluid3D([3008,2898,3117,3284],0); -ELEMENTS[25353] = Fluid3D([3008,2898,3284,3035],0); -ELEMENTS[25354] = Fluid3D([2898,3117,3284,3149],0); -ELEMENTS[25355] = Fluid3D([3284,2898,3149,3107],0); -ELEMENTS[25356] = Fluid3D([3284,2898,3107,3035],0); -ELEMENTS[25357] = Fluid3D([3284,3008,3035,3189],0); -ELEMENTS[25358] = Fluid3D([2898,3117,3149,2714],0); -ELEMENTS[25359] = Fluid3D([3117,3008,3284,3492],0); -ELEMENTS[25360] = Fluid3D([3008,2898,3035,2703],0); -ELEMENTS[25361] = Fluid3D([2898,3149,3107,2957],0); -ELEMENTS[25362] = Fluid3D([2703,2567,2898,2798],0); -ELEMENTS[25363] = Fluid3D([2703,2567,2798,2366],0); -ELEMENTS[25364] = Fluid3D([2567,2898,2798,2751],0); -ELEMENTS[25365] = Fluid3D([2898,2703,2798,3035],0); -ELEMENTS[25366] = Fluid3D([2898,2798,2751,3107],0); -ELEMENTS[25367] = Fluid3D([2567,2898,2751,2714],0); -ELEMENTS[25368] = Fluid3D([2798,2567,2751,2556],0); -ELEMENTS[25369] = Fluid3D([3117,3284,3149,3246],0); -ELEMENTS[25370] = Fluid3D([3149,3117,3246,2714],0); -ELEMENTS[25371] = Fluid3D([3149,3284,3107,3553],0); -ELEMENTS[25372] = Fluid3D([3284,3107,3553,3510],0); -ELEMENTS[25373] = Fluid3D([3107,3553,3510,3520],0); -ELEMENTS[25374] = Fluid3D([3149,3284,3553,3246],0); -ELEMENTS[25375] = Fluid3D([3107,3149,3553,3330],0); -ELEMENTS[25376] = Fluid3D([3553,3510,3520,4057],0); -ELEMENTS[25377] = Fluid3D([3284,3107,3510,3035],0); -ELEMENTS[25378] = Fluid3D([3553,3284,3510,3879],0); -ELEMENTS[25379] = Fluid3D([3510,3553,3879,4057],0); -ELEMENTS[25380] = Fluid3D([3510,3107,3520,3209],0); -ELEMENTS[25381] = Fluid3D([3510,3107,3209,3035],0); -ELEMENTS[25382] = Fluid3D([3107,3520,3209,3132],0); -ELEMENTS[25383] = Fluid3D([3520,3510,3209,3743],0); -ELEMENTS[25384] = Fluid3D([3520,3209,3132,3533],0); -ELEMENTS[25385] = Fluid3D([3510,3209,3743,3417],0); -ELEMENTS[25386] = Fluid3D([3743,3510,3417,3638],0); -ELEMENTS[25387] = Fluid3D([3743,3510,3638,3879],0); -ELEMENTS[25388] = Fluid3D([3743,3510,3879,4057],0); -ELEMENTS[25389] = Fluid3D([3510,3638,3879,3284],0); -ELEMENTS[25390] = Fluid3D([3107,3553,3520,3338],0); -ELEMENTS[25391] = Fluid3D([3107,3553,3338,3330],0); -ELEMENTS[25392] = Fluid3D([3520,3107,3338,3132],0); -ELEMENTS[25393] = Fluid3D([3553,3520,3338,3756],0); -ELEMENTS[25394] = Fluid3D([3338,3553,3756,3330],0); -ELEMENTS[25395] = Fluid3D([3553,3520,3756,4057],0); -ELEMENTS[25396] = Fluid3D([3209,3107,3132,2883],0); -ELEMENTS[25397] = Fluid3D([3209,3107,2883,3035],0); -ELEMENTS[25398] = Fluid3D([3107,3132,2883,2751],0); -ELEMENTS[25399] = Fluid3D([3132,3209,2883,2826],0); -ELEMENTS[25400] = Fluid3D([2883,3132,2826,2777],0); -ELEMENTS[25401] = Fluid3D([3520,3338,3756,3514],0); -ELEMENTS[25402] = Fluid3D([3338,3756,3514,3247],0); -ELEMENTS[25403] = Fluid3D([3514,3338,3247,3132],0); -ELEMENTS[25404] = Fluid3D([3338,3247,3132,2957],0); -ELEMENTS[25405] = Fluid3D([3338,3247,2957,3330],0); -ELEMENTS[25406] = Fluid3D([3338,3247,3330,3756],0); -ELEMENTS[25407] = Fluid3D([2957,3338,3330,3107],0); -ELEMENTS[25408] = Fluid3D([3520,3338,3514,3132],0); -ELEMENTS[25409] = Fluid3D([3756,3520,3514,3935],0); -ELEMENTS[25410] = Fluid3D([2733,2735,2911,2451],0); -ELEMENTS[25411] = Fluid3D([2520,2537,2779,2563],0); -ELEMENTS[25412] = Fluid3D([2520,2537,2563,2271],0); -ELEMENTS[25413] = Fluid3D([2486,2588,2544,2287],0); -ELEMENTS[25414] = Fluid3D([2226,2426,2301,2419],0); -ELEMENTS[25415] = Fluid3D([2301,2226,2419,2170],0); -ELEMENTS[25416] = Fluid3D([2226,2419,2170,2203],0); -ELEMENTS[25417] = Fluid3D([2226,2426,2419,2408],0); -ELEMENTS[25418] = Fluid3D([2426,2419,2408,2703],0); -ELEMENTS[25419] = Fluid3D([2226,2426,2408,2366],0); -ELEMENTS[25420] = Fluid3D([2301,2226,2170,2047],0); -ELEMENTS[25421] = Fluid3D([2426,2301,2419,2735],0); -ELEMENTS[25422] = Fluid3D([2419,2226,2408,2203],0); -ELEMENTS[25423] = Fluid3D([2226,2408,2203,2366],0); -ELEMENTS[25424] = Fluid3D([2408,2203,2366,2415],0); -ELEMENTS[25425] = Fluid3D([2366,2408,2415,2703],0); -ELEMENTS[25426] = Fluid3D([2419,2301,2170,2364],0); -ELEMENTS[25427] = Fluid3D([2419,2301,2364,2735],0); -ELEMENTS[25428] = Fluid3D([2301,2170,2364,2179],0); -ELEMENTS[25429] = Fluid3D([2301,2170,2179,2047],0); -ELEMENTS[25430] = Fluid3D([2364,2301,2179,2406],0); -ELEMENTS[25431] = Fluid3D([2179,2364,2406,2282],0); -ELEMENTS[25432] = Fluid3D([2364,2406,2282,2564],0); -ELEMENTS[25433] = Fluid3D([2364,2406,2564,2582],0); -ELEMENTS[25434] = Fluid3D([2364,2406,2582,2301],0); -ELEMENTS[25435] = Fluid3D([2406,2282,2564,2420],0); -ELEMENTS[25436] = Fluid3D([2406,2564,2582,2705],0); -ELEMENTS[25437] = Fluid3D([2564,2364,2582,2740],0); -ELEMENTS[25438] = Fluid3D([2582,2564,2740,2705],0); -ELEMENTS[25439] = Fluid3D([2564,2364,2740,2512],0); -ELEMENTS[25440] = Fluid3D([2740,2564,2512,2713],0); -ELEMENTS[25441] = Fluid3D([2740,2564,2713,2995],0); -ELEMENTS[25442] = Fluid3D([2564,2364,2512,2282],0); -ELEMENTS[25443] = Fluid3D([2364,2582,2740,2677],0); -ELEMENTS[25444] = Fluid3D([2582,2740,2677,3057],0); -ELEMENTS[25445] = Fluid3D([2364,2582,2677,2735],0); -ELEMENTS[25446] = Fluid3D([2582,2677,2735,2906],0); -ELEMENTS[25447] = Fluid3D([2677,2735,2906,2959],0); -ELEMENTS[25448] = Fluid3D([2906,2677,2959,2924],0); -ELEMENTS[25449] = Fluid3D([2959,2906,2924,3197],0); -ELEMENTS[25450] = Fluid3D([2959,2906,3197,2735],0); -ELEMENTS[25451] = Fluid3D([2677,2959,2924,2728],0); -ELEMENTS[25452] = Fluid3D([2959,2924,2728,3189],0); -ELEMENTS[25453] = Fluid3D([2677,2735,2959,2703],0); -ELEMENTS[25454] = Fluid3D([2677,2959,2728,2703],0); -ELEMENTS[25455] = Fluid3D([2582,2677,2906,3057],0); -ELEMENTS[25456] = Fluid3D([2906,2677,2924,3057],0); -ELEMENTS[25457] = Fluid3D([2924,2906,3057,3197],0); -ELEMENTS[25458] = Fluid3D([2906,3057,3197,3037],0); -ELEMENTS[25459] = Fluid3D([2906,3057,3037,2582],0); -ELEMENTS[25460] = Fluid3D([2959,2924,3189,3256],0); -ELEMENTS[25461] = Fluid3D([2959,2924,3256,3197],0); -ELEMENTS[25462] = Fluid3D([3256,2959,3197,3189],0); -ELEMENTS[25463] = Fluid3D([3197,3256,3189,3638],0); -ELEMENTS[25464] = Fluid3D([2924,2677,2728,2613],0); -ELEMENTS[25465] = Fluid3D([2728,2924,2613,2819],0); -ELEMENTS[25466] = Fluid3D([2728,2924,2819,3016],0); -ELEMENTS[25467] = Fluid3D([2728,2924,3016,3189],0); -ELEMENTS[25468] = Fluid3D([2924,3016,3189,3158],0); -ELEMENTS[25469] = Fluid3D([3016,3189,3158,3417],0); -ELEMENTS[25470] = Fluid3D([3158,3016,3417,3214],0); -ELEMENTS[25471] = Fluid3D([3016,3189,3417,3066],0); -ELEMENTS[25472] = Fluid3D([3016,3189,3066,3035],0); -ELEMENTS[25473] = Fluid3D([3189,3066,3035,3417],0); -ELEMENTS[25474] = Fluid3D([3016,3189,3035,2728],0); -ELEMENTS[25475] = Fluid3D([3066,3016,3035,2717],0); -ELEMENTS[25476] = Fluid3D([3035,3066,2717,2798],0); -ELEMENTS[25477] = Fluid3D([3035,3066,2798,2883],0); -ELEMENTS[25478] = Fluid3D([3066,2798,2883,2605],0); -ELEMENTS[25479] = Fluid3D([2798,2883,2605,2556],0); -ELEMENTS[25480] = Fluid3D([2798,2883,2556,2751],0); -ELEMENTS[25481] = Fluid3D([2798,2883,2751,3107],0); -ELEMENTS[25482] = Fluid3D([3035,3066,2883,3209],0); -ELEMENTS[25483] = Fluid3D([3035,3066,3209,3417],0); -ELEMENTS[25484] = Fluid3D([3066,2717,2798,2605],0); -ELEMENTS[25485] = Fluid3D([3066,2883,3209,2888],0); -ELEMENTS[25486] = Fluid3D([2798,2883,3107,3035],0); -ELEMENTS[25487] = Fluid3D([2819,2728,3016,2813],0); -ELEMENTS[25488] = Fluid3D([2924,2613,2819,2870],0); -ELEMENTS[25489] = Fluid3D([2179,2364,2282,2170],0); -ELEMENTS[25490] = Fluid3D([2924,2613,2870,2740],0); -ELEMENTS[25491] = Fluid3D([2613,2728,2819,2541],0); -ELEMENTS[25492] = Fluid3D([2613,2728,2541,2419],0); -ELEMENTS[25493] = Fluid3D([2728,2819,2541,2813],0); -ELEMENTS[25494] = Fluid3D([2728,3016,2813,2717],0); -ELEMENTS[25495] = Fluid3D([2813,2728,2717,2415],0); -ELEMENTS[25496] = Fluid3D([2728,3016,2717,3035],0); -ELEMENTS[25497] = Fluid3D([2282,2564,2420,2410],0); -ELEMENTS[25498] = Fluid3D([2564,2406,2420,2705],0); -ELEMENTS[25499] = Fluid3D([2406,2179,2282,2234],0); -ELEMENTS[25500] = Fluid3D([2406,2282,2420,2234],0); -ELEMENTS[25501] = Fluid3D([2924,2819,3016,3158],0); -ELEMENTS[25502] = Fluid3D([2819,3016,3158,2813],0); -ELEMENTS[25503] = Fluid3D([2819,2924,2870,3245],0); -ELEMENTS[25504] = Fluid3D([2564,2420,2410,2713],0); -ELEMENTS[25505] = Fluid3D([2410,2564,2713,2512],0); -ELEMENTS[25506] = Fluid3D([2677,2728,2613,2419],0); -ELEMENTS[25507] = Fluid3D([3066,3016,2717,2813],0); -ELEMENTS[25508] = Fluid3D([2819,2613,2541,2581],0); -ELEMENTS[25509] = Fluid3D([2613,2541,2581,2379],0); -ELEMENTS[25510] = Fluid3D([2541,2819,2581,2491],0); -ELEMENTS[25511] = Fluid3D([2541,2581,2379,2322],0); -ELEMENTS[25512] = Fluid3D([2819,2613,2581,2870],0); -ELEMENTS[25513] = Fluid3D([2613,2541,2379,2419],0); -ELEMENTS[25514] = Fluid3D([2170,2419,2364,2343],0); -ELEMENTS[25515] = Fluid3D([2419,2364,2343,2677],0); -ELEMENTS[25516] = Fluid3D([2419,2364,2677,2735],0); -ELEMENTS[25517] = Fluid3D([2170,2419,2343,2062],0); -ELEMENTS[25518] = Fluid3D([2364,2170,2343,2240],0); -ELEMENTS[25519] = Fluid3D([2343,2364,2240,2677],0); -ELEMENTS[25520] = Fluid3D([2170,2343,2240,2062],0); -ELEMENTS[25521] = Fluid3D([2420,2282,2410,2206],0); -ELEMENTS[25522] = Fluid3D([2420,2282,2206,2167],0); -ELEMENTS[25523] = Fluid3D([2410,2420,2206,2427],0); -ELEMENTS[25524] = Fluid3D([2410,2420,2427,2671],0); -ELEMENTS[25525] = Fluid3D([2410,2420,2671,2713],0); -ELEMENTS[25526] = Fluid3D([2671,2410,2713,2620],0); -ELEMENTS[25527] = Fluid3D([2713,2671,2620,2947],0); -ELEMENTS[25528] = Fluid3D([2713,2671,2947,2995],0); -ELEMENTS[25529] = Fluid3D([2671,2620,2947,2706],0); -ELEMENTS[25530] = Fluid3D([2947,2671,2706,2920],0); -ELEMENTS[25531] = Fluid3D([2671,2620,2706,2427],0); -ELEMENTS[25532] = Fluid3D([2706,2671,2427,2606],0); -ELEMENTS[25533] = Fluid3D([2706,2671,2606,2920],0); -ELEMENTS[25534] = Fluid3D([2606,2706,2920,2701],0); -ELEMENTS[25535] = Fluid3D([2427,2706,2606,2701],0); -ELEMENTS[25536] = Fluid3D([2706,2920,2701,2980],0); -ELEMENTS[25537] = Fluid3D([2706,2920,2980,2947],0); -ELEMENTS[25538] = Fluid3D([2980,2706,2947,2620],0); -ELEMENTS[25539] = Fluid3D([2920,2606,2701,2804],0); -ELEMENTS[25540] = Fluid3D([2920,2606,2804,2927],0); -ELEMENTS[25541] = Fluid3D([2804,2920,2927,3313],0); -ELEMENTS[25542] = Fluid3D([2701,2920,2804,3036],0); -ELEMENTS[25543] = Fluid3D([2606,2701,2804,2550],0); -ELEMENTS[25544] = Fluid3D([2671,2410,2620,2427],0); -ELEMENTS[25545] = Fluid3D([2671,2427,2606,2420],0); -ELEMENTS[25546] = Fluid3D([2410,2713,2620,2555],0); -ELEMENTS[25547] = Fluid3D([2713,2620,2555,2823],0); -ELEMENTS[25548] = Fluid3D([2420,2206,2427,2283],0); -ELEMENTS[25549] = Fluid3D([2282,2206,2167,2057],0); -ELEMENTS[25550] = Fluid3D([2206,2427,2283,2197],0); -ELEMENTS[25551] = Fluid3D([2206,2427,2197,2250],0); -ELEMENTS[25552] = Fluid3D([2206,2427,2250,2410],0); -ELEMENTS[25553] = Fluid3D([2713,2671,2995,2420],0); -ELEMENTS[25554] = Fluid3D([2282,2206,2057,2116],0); -ELEMENTS[25555] = Fluid3D([2282,2206,2116,2410],0); -ELEMENTS[25556] = Fluid3D([2057,2282,2116,2240],0); -ELEMENTS[25557] = Fluid3D([2206,2057,2116,2019],0); -ELEMENTS[25558] = Fluid3D([2206,2057,2019,2026],0); -ELEMENTS[25559] = Fluid3D([2206,2057,2026,2167],0); -ELEMENTS[25560] = Fluid3D([2057,2116,2019,1949],0); -ELEMENTS[25561] = Fluid3D([2057,2116,1949,2046],0); -ELEMENTS[25562] = Fluid3D([2057,2116,2046,2240],0); -ELEMENTS[25563] = Fluid3D([2116,2046,2240,2064],0); -ELEMENTS[25564] = Fluid3D([2046,2240,2064,2062],0); -ELEMENTS[25565] = Fluid3D([2116,2046,2064,1949],0); -ELEMENTS[25566] = Fluid3D([2046,2064,1949,1952],0); -ELEMENTS[25567] = Fluid3D([2046,2064,1952,2062],0); -ELEMENTS[25568] = Fluid3D([2064,1949,1952,1856],0); -ELEMENTS[25569] = Fluid3D([1949,1952,1856,1814],0); -ELEMENTS[25570] = Fluid3D([1856,1949,1814,1802],0); -ELEMENTS[25571] = Fluid3D([1856,1949,1802,1919],0); -ELEMENTS[25572] = Fluid3D([1856,1949,1919,2064],0); -ELEMENTS[25573] = Fluid3D([1949,1802,1919,2019],0); -ELEMENTS[25574] = Fluid3D([1919,1949,2019,2116],0); -ELEMENTS[25575] = Fluid3D([1802,1856,1919,1740],0); -ELEMENTS[25576] = Fluid3D([1802,1856,1740,1706],0); -ELEMENTS[25577] = Fluid3D([1740,1802,1706,1644],0); -ELEMENTS[25578] = Fluid3D([1919,1802,1740,1739],0); -ELEMENTS[25579] = Fluid3D([2019,2057,1949,1868],0); -ELEMENTS[25580] = Fluid3D([2019,2057,1868,2026],0); -ELEMENTS[25581] = Fluid3D([1949,2046,1952,1814],0); -ELEMENTS[25582] = Fluid3D([2283,2206,2197,2026],0); -ELEMENTS[25583] = Fluid3D([2606,2804,2927,2538],0); -ELEMENTS[25584] = Fluid3D([2206,2420,2167,2283],0); -ELEMENTS[25585] = Fluid3D([2116,2206,2019,2250],0); -ELEMENTS[25586] = Fluid3D([1949,2019,1868,1802],0); -ELEMENTS[25587] = Fluid3D([1868,1949,1802,1814],0); -ELEMENTS[25588] = Fluid3D([2420,2282,2167,2234],0); -ELEMENTS[25589] = Fluid3D([1949,2057,2046,1906],0); -ELEMENTS[25590] = Fluid3D([2057,2046,1906,2179],0); -ELEMENTS[25591] = Fluid3D([2046,1949,1906,1814],0); -ELEMENTS[25592] = Fluid3D([1949,1906,1814,1868],0); -ELEMENTS[25593] = Fluid3D([1949,2057,1906,1868],0); -ELEMENTS[25594] = Fluid3D([2410,2713,2555,2512],0); -ELEMENTS[25595] = Fluid3D([2427,2420,2283,2606],0); -ELEMENTS[25596] = Fluid3D([2019,2206,2026,2197],0); -ELEMENTS[25597] = Fluid3D([2282,2564,2410,2512],0); -ELEMENTS[25598] = Fluid3D([2197,2206,2250,2019],0); -ELEMENTS[25599] = Fluid3D([2581,2613,2379,2512],0); -ELEMENTS[25600] = Fluid3D([2613,2379,2512,2343],0); -ELEMENTS[25601] = Fluid3D([2613,2379,2343,2419],0); -ELEMENTS[25602] = Fluid3D([2379,2512,2343,2240],0); -ELEMENTS[25603] = Fluid3D([2343,2379,2240,2062],0); -ELEMENTS[25604] = Fluid3D([2512,2343,2240,2677],0); -ELEMENTS[25605] = Fluid3D([2512,2613,2343,2677],0); -ELEMENTS[25606] = Fluid3D([2379,2512,2240,2340],0); -ELEMENTS[25607] = Fluid3D([2240,2379,2340,2114],0); -ELEMENTS[25608] = Fluid3D([2167,2282,2057,2179],0); -ELEMENTS[25609] = Fluid3D([2098,2290,2087,2171],0); -ELEMENTS[25610] = Fluid3D([2926,2779,2639,3112],0); -ELEMENTS[25611] = Fluid3D([2271,2287,2086,2266],0); -ELEMENTS[25612] = Fluid3D([2086,2271,2266,2080],0); -ELEMENTS[25613] = Fluid3D([2196,2163,2123,1967],0); -ELEMENTS[25614] = Fluid3D([2199,2071,2047,2018],0); -ELEMENTS[25615] = Fluid3D([2427,2283,2197,2409],0); -ELEMENTS[25616] = Fluid3D([2283,2197,2409,2193],0); -ELEMENTS[25617] = Fluid3D([2427,2283,2409,2606],0); -ELEMENTS[25618] = Fluid3D([2197,2409,2193,2224],0); -ELEMENTS[25619] = Fluid3D([2193,2197,2224,1969],0); -ELEMENTS[25620] = Fluid3D([2197,2409,2224,2390],0); -ELEMENTS[25621] = Fluid3D([2197,2409,2390,2427],0); -ELEMENTS[25622] = Fluid3D([2409,2224,2390,2468],0); -ELEMENTS[25623] = Fluid3D([2390,2409,2468,2654],0); -ELEMENTS[25624] = Fluid3D([2409,2224,2468,2350],0); -ELEMENTS[25625] = Fluid3D([2409,2224,2350,2193],0); -ELEMENTS[25626] = Fluid3D([2409,2468,2654,2701],0); -ELEMENTS[25627] = Fluid3D([2654,2409,2701,2427],0); -ELEMENTS[25628] = Fluid3D([2468,2654,2701,2828],0); -ELEMENTS[25629] = Fluid3D([2654,2701,2828,2980],0); -ELEMENTS[25630] = Fluid3D([2390,2409,2654,2427],0); -ELEMENTS[25631] = Fluid3D([2224,2390,2468,2279],0); -ELEMENTS[25632] = Fluid3D([2390,2468,2279,2577],0); -ELEMENTS[25633] = Fluid3D([2224,2390,2279,2146],0); -ELEMENTS[25634] = Fluid3D([2390,2279,2146,2339],0); -ELEMENTS[25635] = Fluid3D([2390,2279,2339,2610],0); -ELEMENTS[25636] = Fluid3D([2390,2279,2610,2577],0); -ELEMENTS[25637] = Fluid3D([2279,2610,2577,2480],0); -ELEMENTS[25638] = Fluid3D([2610,2577,2480,2932],0); -ELEMENTS[25639] = Fluid3D([2279,2610,2480,2339],0); -ELEMENTS[25640] = Fluid3D([2146,2390,2339,2250],0); -ELEMENTS[25641] = Fluid3D([2468,2224,2279,2132],0); -ELEMENTS[25642] = Fluid3D([2224,2390,2146,2197],0); -ELEMENTS[25643] = Fluid3D([2224,2468,2350,2132],0); -ELEMENTS[25644] = Fluid3D([2339,2390,2610,2547],0); -ELEMENTS[25645] = Fluid3D([2339,2390,2547,2250],0); -ELEMENTS[25646] = Fluid3D([2390,2610,2547,2654],0); -ELEMENTS[25647] = Fluid3D([2610,2339,2547,2593],0); -ELEMENTS[25648] = Fluid3D([2547,2610,2593,2843],0); -ELEMENTS[25649] = Fluid3D([2547,2610,2843,2654],0); -ELEMENTS[25650] = Fluid3D([2610,2339,2593,2480],0); -ELEMENTS[25651] = Fluid3D([2279,2224,2146,2022],0); -ELEMENTS[25652] = Fluid3D([2339,2547,2593,2407],0); -ELEMENTS[25653] = Fluid3D([2339,2547,2407,2250],0); -ELEMENTS[25654] = Fluid3D([2547,2593,2407,2910],0); -ELEMENTS[25655] = Fluid3D([2593,2339,2407,2352],0); -ELEMENTS[25656] = Fluid3D([2593,2339,2352,2480],0); -ELEMENTS[25657] = Fluid3D([2407,2593,2352,2532],0); -ELEMENTS[25658] = Fluid3D([2593,2352,2532,2820],0); -ELEMENTS[25659] = Fluid3D([2407,2593,2532,2910],0); -ELEMENTS[25660] = Fluid3D([2339,2407,2352,2162],0); -ELEMENTS[25661] = Fluid3D([2339,2407,2162,2250],0); -ELEMENTS[25662] = Fluid3D([2352,2339,2162,2166],0); -ELEMENTS[25663] = Fluid3D([2352,2339,2166,2480],0); -ELEMENTS[25664] = Fluid3D([2407,2352,2162,2272],0); -ELEMENTS[25665] = Fluid3D([2407,2352,2272,2532],0); -ELEMENTS[25666] = Fluid3D([2162,2352,2166,2118],0); -ELEMENTS[25667] = Fluid3D([2352,2162,2272,2118],0); -ELEMENTS[25668] = Fluid3D([2166,2162,2118,1922],0); -ELEMENTS[25669] = Fluid3D([2610,2593,2843,2932],0); -ELEMENTS[25670] = Fluid3D([2339,2162,2166,2146],0); -ELEMENTS[25671] = Fluid3D([2352,2166,2118,2253],0); -ELEMENTS[25672] = Fluid3D([2352,2166,2253,2480],0); -ELEMENTS[25673] = Fluid3D([2166,2118,2253,1987],0); -ELEMENTS[25674] = Fluid3D([2118,2352,2253,2318],0); -ELEMENTS[25675] = Fluid3D([2352,2253,2318,2466],0); -ELEMENTS[25676] = Fluid3D([2352,2253,2466,2480],0); -ELEMENTS[25677] = Fluid3D([2253,2318,2466,2327],0); -ELEMENTS[25678] = Fluid3D([2466,2253,2327,2374],0); -ELEMENTS[25679] = Fluid3D([2253,2318,2327,2052],0); -ELEMENTS[25680] = Fluid3D([2118,2352,2318,2272],0); -ELEMENTS[25681] = Fluid3D([2253,2118,2318,2052],0); -ELEMENTS[25682] = Fluid3D([2283,2197,2193,2026],0); -ELEMENTS[25683] = Fluid3D([2468,2390,2654,2577],0); -ELEMENTS[25684] = Fluid3D([2279,2146,2339,2166],0); -ELEMENTS[25685] = Fluid3D([2162,2407,2272,2262],0); -ELEMENTS[25686] = Fluid3D([2162,2407,2262,2250],0); -ELEMENTS[25687] = Fluid3D([2407,2272,2262,2598],0); -ELEMENTS[25688] = Fluid3D([2272,2162,2262,2045],0); -ELEMENTS[25689] = Fluid3D([2162,2262,2045,1989],0); -ELEMENTS[25690] = Fluid3D([2272,2162,2045,2118],0); -ELEMENTS[25691] = Fluid3D([2045,2162,1989,1916],0); -ELEMENTS[25692] = Fluid3D([2162,1989,1916,2038],0); -ELEMENTS[25693] = Fluid3D([2162,1989,2038,2250],0); -ELEMENTS[25694] = Fluid3D([2262,2272,2045,2188],0); -ELEMENTS[25695] = Fluid3D([2045,2262,2188,2033],0); -ELEMENTS[25696] = Fluid3D([2045,2262,2033,1989],0); -ELEMENTS[25697] = Fluid3D([2272,2045,2188,2122],0); -ELEMENTS[25698] = Fluid3D([2272,2045,2122,2118],0); -ELEMENTS[25699] = Fluid3D([2262,2272,2188,2380],0); -ELEMENTS[25700] = Fluid3D([2262,2272,2380,2598],0); -ELEMENTS[25701] = Fluid3D([2188,2272,2122,2365],0); -ELEMENTS[25702] = Fluid3D([2122,2188,2365,2027],0); -ELEMENTS[25703] = Fluid3D([2188,2272,2365,2380],0); -ELEMENTS[25704] = Fluid3D([2272,2122,2365,2318],0); -ELEMENTS[25705] = Fluid3D([2162,2262,1989,2250],0); -ELEMENTS[25706] = Fluid3D([2045,2162,1916,2118],0); -ELEMENTS[25707] = Fluid3D([1989,1916,2038,1870],0); -ELEMENTS[25708] = Fluid3D([2038,1989,1870,2019],0); -ELEMENTS[25709] = Fluid3D([1989,1916,1870,1785],0); -ELEMENTS[25710] = Fluid3D([1916,2038,1870,1922],0); -ELEMENTS[25711] = Fluid3D([2188,2045,2033,1961],0); -ELEMENTS[25712] = Fluid3D([2033,2188,1961,2054],0); -ELEMENTS[25713] = Fluid3D([1961,2033,2054,1897],0); -ELEMENTS[25714] = Fluid3D([1961,2033,1897,1893],0); -ELEMENTS[25715] = Fluid3D([1961,2033,1893,2045],0); -ELEMENTS[25716] = Fluid3D([2033,1893,2045,1989],0); -ELEMENTS[25717] = Fluid3D([1893,2045,1989,1916],0); -ELEMENTS[25718] = Fluid3D([2033,1897,1893,1989],0); -ELEMENTS[25719] = Fluid3D([2033,2054,1897,2075],0); -ELEMENTS[25720] = Fluid3D([1897,2033,2075,1989],0); -ELEMENTS[25721] = Fluid3D([2033,2054,2075,2233],0); -ELEMENTS[25722] = Fluid3D([2033,2054,2233,2188],0); -ELEMENTS[25723] = Fluid3D([2075,2033,2233,2262],0); -ELEMENTS[25724] = Fluid3D([2033,2233,2262,2188],0); -ELEMENTS[25725] = Fluid3D([2233,2262,2188,2380],0); -ELEMENTS[25726] = Fluid3D([1893,2045,1916,1910],0); -ELEMENTS[25727] = Fluid3D([1893,2045,1910,1961],0); -ELEMENTS[25728] = Fluid3D([2233,2262,2380,2598],0); -ELEMENTS[25729] = Fluid3D([2045,1916,1910,2118],0); -ELEMENTS[25730] = Fluid3D([2054,2075,2233,2182],0); -ELEMENTS[25731] = Fluid3D([1989,1893,1916,1785],0); -ELEMENTS[25732] = Fluid3D([1916,2162,2038,1922],0); -ELEMENTS[25733] = Fluid3D([2045,2188,2122,1961],0); -ELEMENTS[25734] = Fluid3D([2409,2283,2193,2550],0); -ELEMENTS[25735] = Fluid3D([2468,2409,2350,2701],0); -ELEMENTS[25736] = Fluid3D([2593,2547,2843,2910],0); -ELEMENTS[25737] = Fluid3D([2432,2527,2290,2537],0); -ELEMENTS[25738] = Fluid3D([2427,2197,2250,2390],0); -ELEMENTS[25739] = Fluid3D([2178,2098,2087,1975],0); -ELEMENTS[25740] = Fluid3D([2096,2287,2338,2270],0); -ELEMENTS[25741] = Fluid3D([2338,2096,2270,2074],0); -ELEMENTS[25742] = Fluid3D([2096,2287,2270,2065],0); -ELEMENTS[25743] = Fluid3D([2270,2096,2065,2074],0); -ELEMENTS[25744] = Fluid3D([2096,2065,2074,1928],0); -ELEMENTS[25745] = Fluid3D([2096,2065,1928,2086],0); -ELEMENTS[25746] = Fluid3D([2287,2338,2270,2486],0); -ELEMENTS[25747] = Fluid3D([2199,2239,2451,2301],0); -ELEMENTS[25748] = Fluid3D([2290,2527,2292,2440],0); -ELEMENTS[25749] = Fluid3D([2811,2876,3126,3139],0); -ELEMENTS[25750] = Fluid3D([2876,3126,3139,3339],0); -ELEMENTS[25751] = Fluid3D([2341,2524,2354,2454],0); -ELEMENTS[25752] = Fluid3D([2341,2524,2454,2439],0); -ELEMENTS[25753] = Fluid3D([2524,2354,2454,2476],0); -ELEMENTS[25754] = Fluid3D([2056,2178,1975,2098],0); -ELEMENTS[25755] = Fluid3D([2239,2298,2451,2455],0); -ELEMENTS[25756] = Fluid3D([2527,2275,2292,2485],0); -ELEMENTS[25757] = Fluid3D([2537,2440,2779,2527],0); -ELEMENTS[25758] = Fluid3D([2087,2290,2271,2260],0); -ELEMENTS[25759] = Fluid3D([2087,2290,2260,2171],0); -ELEMENTS[25760] = Fluid3D([2271,2087,2260,2080],0); -ELEMENTS[25761] = Fluid3D([2290,2271,2260,2537],0); -ELEMENTS[25762] = Fluid3D([2338,2178,2056,2292],0); -ELEMENTS[25763] = Fluid3D([2292,2275,2098,2185],0); -ELEMENTS[25764] = Fluid3D([2086,2287,2096,2213],0); -ELEMENTS[25765] = Fluid3D([2735,3008,2911,3197],0); -ELEMENTS[25766] = Fluid3D([2287,2271,2520,2266],0); -ELEMENTS[25767] = Fluid3D([2271,2520,2266,2563],0); -ELEMENTS[25768] = Fluid3D([15222,15866,15709,15314],0); -ELEMENTS[25769] = Fluid3D([17932,17622,17925,17824],0); -ELEMENTS[25770] = Fluid3D([17925,17932,17824,18117],0); -ELEMENTS[25771] = Fluid3D([17932,17622,17824,17602],0); -ELEMENTS[25772] = Fluid3D([17932,17824,18117,18008],0); -ELEMENTS[25773] = Fluid3D([17932,17824,18008,17602],0); -ELEMENTS[25774] = Fluid3D([18117,17932,18008,18315],0); -ELEMENTS[25775] = Fluid3D([17824,18117,18008,18041],0); -ELEMENTS[25776] = Fluid3D([18008,17824,18041,17743],0); -ELEMENTS[25777] = Fluid3D([18041,18008,17743,18062],0); -ELEMENTS[25778] = Fluid3D([18041,18008,18062,18244],0); -ELEMENTS[25779] = Fluid3D([18041,18008,18244,18117],0); -ELEMENTS[25780] = Fluid3D([17824,18117,18041,18004],0); -ELEMENTS[25781] = Fluid3D([18041,17824,18004,17782],0); -ELEMENTS[25782] = Fluid3D([18041,17824,17782,17743],0); -ELEMENTS[25783] = Fluid3D([18062,18041,18244,18207],0); -ELEMENTS[25784] = Fluid3D([17824,18117,18004,17925],0); -ELEMENTS[25785] = Fluid3D([18008,17824,17743,17602],0); -ELEMENTS[25786] = Fluid3D([18117,18041,18004,18360],0); -ELEMENTS[25787] = Fluid3D([17743,18041,18062,17996],0); -ELEMENTS[25788] = Fluid3D([18062,17743,17996,17839],0); -ELEMENTS[25789] = Fluid3D([17996,18062,17839,18114],0); -ELEMENTS[25790] = Fluid3D([17996,18062,18114,18213],0); -ELEMENTS[25791] = Fluid3D([18062,17839,18114,18067],0); -ELEMENTS[25792] = Fluid3D([18041,18062,17996,18207],0); -ELEMENTS[25793] = Fluid3D([17839,17996,18114,17857],0); -ELEMENTS[25794] = Fluid3D([17996,18114,17857,18213],0); -ELEMENTS[25795] = Fluid3D([17839,17996,17857,17787],0); -ELEMENTS[25796] = Fluid3D([18062,17743,17839,17721],0); -ELEMENTS[25797] = Fluid3D([17743,17839,17721,17515],0); -ELEMENTS[25798] = Fluid3D([17721,17743,17515,17469],0); -ELEMENTS[25799] = Fluid3D([17721,17743,17469,17602],0); -ELEMENTS[25800] = Fluid3D([17515,17721,17469,17136],0); -ELEMENTS[25801] = Fluid3D([17743,17515,17469,17470],0); -ELEMENTS[25802] = Fluid3D([18114,17839,17857,17936],0); -ELEMENTS[25803] = Fluid3D([17857,18114,17936,18172],0); -ELEMENTS[25804] = Fluid3D([17857,18114,18172,18213],0); -ELEMENTS[25805] = Fluid3D([17839,17857,17936,17555],0); -ELEMENTS[25806] = Fluid3D([17839,17857,17555,17515],0); -ELEMENTS[25807] = Fluid3D([17839,17721,17515,17619],0); -ELEMENTS[25808] = Fluid3D([17857,17936,17555,17810],0); -ELEMENTS[25809] = Fluid3D([17857,17936,17810,18172],0); -ELEMENTS[25810] = Fluid3D([17936,17555,17810,17663],0); -ELEMENTS[25811] = Fluid3D([17810,17936,17663,17958],0); -ELEMENTS[25812] = Fluid3D([17810,17936,17958,18172],0); -ELEMENTS[25813] = Fluid3D([17555,17857,17810,17593],0); -ELEMENTS[25814] = Fluid3D([17857,17810,17593,17913],0); -ELEMENTS[25815] = Fluid3D([17810,17593,17913,17640],0); -ELEMENTS[25816] = Fluid3D([17936,17555,17663,17670],0); -ELEMENTS[25817] = Fluid3D([17936,17555,17670,17839],0); -ELEMENTS[25818] = Fluid3D([17810,17593,17640,17429],0); -ELEMENTS[25819] = Fluid3D([17810,17593,17429,17555],0); -ELEMENTS[25820] = Fluid3D([17593,17640,17429,17123],0); -ELEMENTS[25821] = Fluid3D([17857,17810,17913,18103],0); -ELEMENTS[25822] = Fluid3D([17810,17913,18103,17640],0); -ELEMENTS[25823] = Fluid3D([17555,17857,17593,17620],0); -ELEMENTS[25824] = Fluid3D([17857,17593,17620,17787],0); -ELEMENTS[25825] = Fluid3D([17620,17857,17787,17515],0); -ELEMENTS[25826] = Fluid3D([17787,17620,17515,17470],0); -ELEMENTS[25827] = Fluid3D([17787,17620,17470,17441],0); -ELEMENTS[25828] = Fluid3D([17787,17620,17441,17593],0); -ELEMENTS[25829] = Fluid3D([17470,17787,17441,17417],0); -ELEMENTS[25830] = Fluid3D([17620,17515,17470,17441],0); -ELEMENTS[25831] = Fluid3D([17620,17515,17441,17283],0); -ELEMENTS[25832] = Fluid3D([17620,17515,17283,17555],0); -ELEMENTS[25833] = Fluid3D([17441,17620,17283,17555],0); -ELEMENTS[25834] = Fluid3D([17620,17515,17555,17857],0); -ELEMENTS[25835] = Fluid3D([17441,17470,17417,17163],0); -ELEMENTS[25836] = Fluid3D([17441,17470,17163,17283],0); -ELEMENTS[25837] = Fluid3D([17417,17441,17163,17431],0); -ELEMENTS[25838] = Fluid3D([17163,17441,17283,17320],0); -ELEMENTS[25839] = Fluid3D([17163,17441,17320,17431],0); -ELEMENTS[25840] = Fluid3D([17620,17441,17593,17555],0); -ELEMENTS[25841] = Fluid3D([17555,17663,17670,17168],0); -ELEMENTS[25842] = Fluid3D([18004,18041,17782,18063],0); -ELEMENTS[25843] = Fluid3D([18004,18041,18063,18360],0); -ELEMENTS[25844] = Fluid3D([18041,17782,18063,18038],0); -ELEMENTS[25845] = Fluid3D([17782,18004,18063,17720],0); -ELEMENTS[25846] = Fluid3D([17593,17913,17640,17664],0); -ELEMENTS[25847] = Fluid3D([17913,17640,17664,17877],0); -ELEMENTS[25848] = Fluid3D([17664,17913,17877,18012],0); -ELEMENTS[25849] = Fluid3D([17640,17593,17664,17320],0); -ELEMENTS[25850] = Fluid3D([17593,17664,17320,17441],0); -ELEMENTS[25851] = Fluid3D([17593,17913,17664,17979],0); -ELEMENTS[25852] = Fluid3D([17913,17640,17877,18103],0); -ELEMENTS[25853] = Fluid3D([17877,17913,18103,18012],0); -ELEMENTS[25854] = Fluid3D([17640,17664,17877,17563],0); -ELEMENTS[25855] = Fluid3D([17640,17664,17563,17306],0); -ELEMENTS[25856] = Fluid3D([17877,17640,17563,17744],0); -ELEMENTS[25857] = Fluid3D([17877,17640,17744,17949],0); -ELEMENTS[25858] = Fluid3D([17877,17640,17949,18103],0); -ELEMENTS[25859] = Fluid3D([17563,17640,17306,17322],0); -ELEMENTS[25860] = Fluid3D([17563,17640,17322,17744],0); -ELEMENTS[25861] = Fluid3D([17640,17306,17322,17123],0); -ELEMENTS[25862] = Fluid3D([17640,17664,17306,17320],0); -ELEMENTS[25863] = Fluid3D([17664,17306,17320,17313],0); -ELEMENTS[25864] = Fluid3D([17306,17320,17313,16750],0); -ELEMENTS[25865] = Fluid3D([17664,17306,17313,17563],0); -ELEMENTS[25866] = Fluid3D([17640,17744,17949,17674],0); -ELEMENTS[25867] = Fluid3D([17640,17744,17674,17322],0); -ELEMENTS[25868] = Fluid3D([17949,17640,17674,17810],0); -ELEMENTS[25869] = Fluid3D([17744,17949,17674,17911],0); -ELEMENTS[25870] = Fluid3D([17674,17744,17911,17570],0); -ELEMENTS[25871] = Fluid3D([17674,17744,17570,17322],0); -ELEMENTS[25872] = Fluid3D([17744,17949,17911,18052],0); -ELEMENTS[25873] = Fluid3D([17911,17744,18052,17831],0); -ELEMENTS[25874] = Fluid3D([18052,17911,17831,18125],0); -ELEMENTS[25875] = Fluid3D([17911,17831,18125,17914],0); -ELEMENTS[25876] = Fluid3D([18052,17911,18125,18144],0); -ELEMENTS[25877] = Fluid3D([18052,17911,18144,17949],0); -ELEMENTS[25878] = Fluid3D([17911,18144,17949,18102],0); -ELEMENTS[25879] = Fluid3D([18144,17949,18102,18302],0); -ELEMENTS[25880] = Fluid3D([18102,18144,18302,18351],0); -ELEMENTS[25881] = Fluid3D([17911,18125,18144,18102],0); -ELEMENTS[25882] = Fluid3D([17911,17744,17831,17570],0); -ELEMENTS[25883] = Fluid3D([17831,17911,17570,17914],0); -ELEMENTS[25884] = Fluid3D([18144,17949,18302,18247],0); -ELEMENTS[25885] = Fluid3D([17949,17674,17911,18102],0); -ELEMENTS[25886] = Fluid3D([17664,17877,17563,17727],0); -ELEMENTS[25887] = Fluid3D([17911,17674,17570,17724],0); -ELEMENTS[25888] = Fluid3D([17911,17674,17724,18102],0); -ELEMENTS[25889] = Fluid3D([17674,17570,17724,17391],0); -ELEMENTS[25890] = Fluid3D([17724,17674,17391,17852],0); -ELEMENTS[25891] = Fluid3D([17570,17911,17724,17914],0); -ELEMENTS[25892] = Fluid3D([17555,17810,17663,17429],0); -ELEMENTS[25893] = Fluid3D([17663,17810,17958,17712],0); -ELEMENTS[25894] = Fluid3D([17958,17663,17712,17909],0); -ELEMENTS[25895] = Fluid3D([17663,17810,17712,17429],0); -ELEMENTS[25896] = Fluid3D([17712,17958,17909,17852],0); -ELEMENTS[25897] = Fluid3D([17958,17663,17909,17936],0); -ELEMENTS[25898] = Fluid3D([17810,17958,17712,17949],0); -ELEMENTS[25899] = Fluid3D([17663,17712,17909,17433],0); -ELEMENTS[25900] = Fluid3D([17663,17712,17433,17296],0); -ELEMENTS[25901] = Fluid3D([17958,17909,17852,18102],0); -ELEMENTS[25902] = Fluid3D([17663,17712,17296,17429],0); -ELEMENTS[25903] = Fluid3D([17712,17296,17429,17674],0); -ELEMENTS[25904] = Fluid3D([17810,17712,17429,17674],0); -ELEMENTS[25905] = Fluid3D([17306,17563,17322,17057],0); -ELEMENTS[25906] = Fluid3D([17563,17322,17057,17370],0); -ELEMENTS[25907] = Fluid3D([17322,17306,17057,16717],0); -ELEMENTS[25908] = Fluid3D([17306,17563,17057,17313],0); -ELEMENTS[25909] = Fluid3D([18114,17839,17936,18067],0); -ELEMENTS[25910] = Fluid3D([17593,17857,17913,17979],0); -ELEMENTS[25911] = Fluid3D([17857,17913,17979,18103],0); -ELEMENTS[25912] = Fluid3D([17622,17925,17824,17616],0); -ELEMENTS[25913] = Fluid3D([17925,17824,17616,18004],0); -ELEMENTS[25914] = Fluid3D([17622,17925,17616,17607],0); -ELEMENTS[25915] = Fluid3D([17824,17622,17616,17469],0); -ELEMENTS[25916] = Fluid3D([17824,18004,17782,17616],0); -ELEMENTS[25917] = Fluid3D([17663,17936,17670,17904],0); -ELEMENTS[25918] = Fluid3D([17663,17936,17904,17909],0); -ELEMENTS[25919] = Fluid3D([17904,17663,17909,17433],0); -ELEMENTS[25920] = Fluid3D([17904,17663,17433,17670],0); -ELEMENTS[25921] = Fluid3D([17663,17433,17670,17168],0); -ELEMENTS[25922] = Fluid3D([17663,17433,17168,17429],0); -ELEMENTS[25923] = Fluid3D([17936,17670,17904,17978],0); -ELEMENTS[25924] = Fluid3D([17936,17670,17978,18067],0); -ELEMENTS[25925] = Fluid3D([17904,17936,17978,18264],0); -ELEMENTS[25926] = Fluid3D([17670,17904,17978,17875],0); -ELEMENTS[25927] = Fluid3D([18008,17743,18062,17721],0); -ELEMENTS[25928] = Fluid3D([17925,17932,18117,18131],0); -ELEMENTS[25929] = Fluid3D([17640,17810,17429,17674],0); -ELEMENTS[25930] = Fluid3D([17744,17877,17949,18052],0); -ELEMENTS[25931] = Fluid3D([18008,18062,18244,18067],0); -ELEMENTS[25932] = Fluid3D([17563,17877,17744,17988],0); -ELEMENTS[25933] = Fluid3D([10660,11686,11369,10912],0); -ELEMENTS[25934] = Fluid3D([12240,12605,12903,11795],0); -ELEMENTS[25935] = Fluid3D([13375,13704,12660,13898],0); -ELEMENTS[25936] = Fluid3D([6217,5542,5954,5885],0); -ELEMENTS[25937] = Fluid3D([5542,5954,5885,5450],0); -ELEMENTS[25938] = Fluid3D([5954,6217,5885,6559],0); -ELEMENTS[25939] = Fluid3D([5885,5954,6559,6810],0); -ELEMENTS[25940] = Fluid3D([5954,6217,6559,6530],0); -ELEMENTS[25941] = Fluid3D([6559,5954,6530,6925],0); -ELEMENTS[25942] = Fluid3D([6530,6559,6925,7172],0); -ELEMENTS[25943] = Fluid3D([6559,6925,7172,7316],0); -ELEMENTS[25944] = Fluid3D([6559,6925,7316,6810],0); -ELEMENTS[25945] = Fluid3D([6559,6925,6810,5954],0); -ELEMENTS[25946] = Fluid3D([7316,6559,6810,6337],0); -ELEMENTS[25947] = Fluid3D([6925,7316,6810,7812],0); -ELEMENTS[25948] = Fluid3D([6925,6530,7172,7340],0); -ELEMENTS[25949] = Fluid3D([6925,7172,7316,7764],0); -ELEMENTS[25950] = Fluid3D([6925,6530,7340,6802],0); -ELEMENTS[25951] = Fluid3D([7172,6925,7340,7764],0); -ELEMENTS[25952] = Fluid3D([6925,7340,7764,7711],0); -ELEMENTS[25953] = Fluid3D([7340,7172,7764,7907],0); -ELEMENTS[25954] = Fluid3D([7172,7764,7907,7316],0); -ELEMENTS[25955] = Fluid3D([7316,6925,7764,7812],0); -ELEMENTS[25956] = Fluid3D([7764,7316,7812,8198],0); -ELEMENTS[25957] = Fluid3D([7812,7764,8198,8533],0); -ELEMENTS[25958] = Fluid3D([7316,7812,8198,7728],0); -ELEMENTS[25959] = Fluid3D([7764,7316,8198,7907],0); -ELEMENTS[25960] = Fluid3D([7172,6559,7316,7041],0); -ELEMENTS[25961] = Fluid3D([6559,7316,7041,6337],0); -ELEMENTS[25962] = Fluid3D([8198,7764,7907,8533],0); -ELEMENTS[25963] = Fluid3D([7316,7172,7041,7907],0); -ELEMENTS[25964] = Fluid3D([6530,6559,7172,6890],0); -ELEMENTS[25965] = Fluid3D([6559,7172,6890,7041],0); -ELEMENTS[25966] = Fluid3D([7172,6890,7041,7907],0); -ELEMENTS[25967] = Fluid3D([6925,7764,7812,7711],0); -ELEMENTS[25968] = Fluid3D([7764,7812,7711,8533],0); -ELEMENTS[25969] = Fluid3D([6530,7172,7340,6986],0); -ELEMENTS[25970] = Fluid3D([7340,6530,6986,7299],0); -ELEMENTS[25971] = Fluid3D([6530,7172,6986,6890],0); -ELEMENTS[25972] = Fluid3D([7172,7340,6986,7723],0); -ELEMENTS[25973] = Fluid3D([6986,7340,7299,7723],0); -ELEMENTS[25974] = Fluid3D([7172,6986,6890,7929],0); -ELEMENTS[25975] = Fluid3D([8226,7707,7354,7928],0); -ELEMENTS[25976] = Fluid3D([2670,2465,2705,2927],0); -ELEMENTS[25977] = Fluid3D([10340,10356,9477,10529],0); -ELEMENTS[25978] = Fluid3D([10340,10356,10529,11498],0); -ELEMENTS[25979] = Fluid3D([9477,10340,10529,10104],0); -ELEMENTS[25980] = Fluid3D([10356,9477,10529,10255],0); -ELEMENTS[25981] = Fluid3D([13310,14226,13768,13738],0); -ELEMENTS[25982] = Fluid3D([14226,13768,13738,14437],0); -ELEMENTS[25983] = Fluid3D([10720,10559,11423,10831],0); -ELEMENTS[25984] = Fluid3D([4544,5017,5093,4750],0); -ELEMENTS[25985] = Fluid3D([13009,13760,12958,13093],0); -ELEMENTS[25986] = Fluid3D([13760,12958,13093,13548],0); -ELEMENTS[25987] = Fluid3D([12958,13009,13093,12065],0); -ELEMENTS[25988] = Fluid3D([12958,13093,13548,12699],0); -ELEMENTS[25989] = Fluid3D([13093,13548,12699,13287],0); -ELEMENTS[25990] = Fluid3D([12699,13093,13287,12234],0); -ELEMENTS[25991] = Fluid3D([12958,13093,12699,12065],0); -ELEMENTS[25992] = Fluid3D([13093,12699,12065,12234],0); -ELEMENTS[25993] = Fluid3D([13548,12958,12699,13210],0); -ELEMENTS[25994] = Fluid3D([13009,13760,13093,13668],0); -ELEMENTS[25995] = Fluid3D([13009,13093,12065,12721],0); -ELEMENTS[25996] = Fluid3D([12065,13009,12721,12144],0); -ELEMENTS[25997] = Fluid3D([13009,13093,12721,13668],0); -ELEMENTS[25998] = Fluid3D([13093,12065,12721,12234],0); -ELEMENTS[25999] = Fluid3D([13760,12958,13548,14194],0); -ELEMENTS[26000] = Fluid3D([12958,13009,12065,12466],0); -ELEMENTS[26001] = Fluid3D([13093,13760,13548,13955],0); -ELEMENTS[26002] = Fluid3D([13093,13760,13955,13668],0); -ELEMENTS[26003] = Fluid3D([13760,13548,13955,14528],0); -ELEMENTS[26004] = Fluid3D([13548,13093,13955,13287],0); -ELEMENTS[26005] = Fluid3D([13093,13955,13287,13190],0); -ELEMENTS[26006] = Fluid3D([11053,11124,11709,11908],0); -ELEMENTS[26007] = Fluid3D([12824,13180,12239,12785],0); -ELEMENTS[26008] = Fluid3D([12239,12824,12785,12330],0); -ELEMENTS[26009] = Fluid3D([12824,12785,12330,13518],0); -ELEMENTS[26010] = Fluid3D([12824,13180,12785,13721],0); -ELEMENTS[26011] = Fluid3D([13180,12239,12785,13320],0); -ELEMENTS[26012] = Fluid3D([16515,16167,16611,16194],0); -ELEMENTS[26013] = Fluid3D([13207,13637,13818,12891],0); -ELEMENTS[26014] = Fluid3D([10105,9478,9652,9179],0); -ELEMENTS[26015] = Fluid3D([5838,5643,6084,5438],0); -ELEMENTS[26016] = Fluid3D([5643,6084,5438,5549],0); -ELEMENTS[26017] = Fluid3D([5838,5643,5438,5238],0); -ELEMENTS[26018] = Fluid3D([6084,5838,5438,5927],0); -ELEMENTS[26019] = Fluid3D([5838,5438,5927,5304],0); -ELEMENTS[26020] = Fluid3D([6084,5838,5927,6531],0); -ELEMENTS[26021] = Fluid3D([5438,6084,5927,5665],0); -ELEMENTS[26022] = Fluid3D([5927,5438,5665,5394],0); -ELEMENTS[26023] = Fluid3D([5438,5665,5394,4851],0); -ELEMENTS[26024] = Fluid3D([5665,5927,5394,5711],0); -ELEMENTS[26025] = Fluid3D([5394,5665,5711,4851],0); -ELEMENTS[26026] = Fluid3D([5927,5438,5394,5304],0); -ELEMENTS[26027] = Fluid3D([6248,6427,7034,6126],0); -ELEMENTS[26028] = Fluid3D([8959,9098,8683,8246],0); -ELEMENTS[26029] = Fluid3D([4546,4863,4414,4742],0); -ELEMENTS[26030] = Fluid3D([4414,4546,4742,4106],0); -ELEMENTS[26031] = Fluid3D([18007,18238,17930,17966],0); -ELEMENTS[26032] = Fluid3D([3069,2978,3138,2760],0); -ELEMENTS[26033] = Fluid3D([14607,13978,13952,14631],0); -ELEMENTS[26034] = Fluid3D([10306,9226,9725,9184],0); -ELEMENTS[26035] = Fluid3D([17638,17342,17264,17273],0); -ELEMENTS[26036] = Fluid3D([16146,15649,15796,16235],0); -ELEMENTS[26037] = Fluid3D([16146,15649,16235,15935],0); -ELEMENTS[26038] = Fluid3D([10169,9340,9628,9431],0); -ELEMENTS[26039] = Fluid3D([9628,10169,9431,10766],0); -ELEMENTS[26040] = Fluid3D([9340,9628,9431,8677],0); -ELEMENTS[26041] = Fluid3D([9431,9340,8677,9530],0); -ELEMENTS[26042] = Fluid3D([8677,9431,9530,9458],0); -ELEMENTS[26043] = Fluid3D([8677,9431,9458,9017],0); -ELEMENTS[26044] = Fluid3D([9431,9458,9017,10455],0); -ELEMENTS[26045] = Fluid3D([8677,9431,9017,9628],0); -ELEMENTS[26046] = Fluid3D([9431,9530,9458,10169],0); -ELEMENTS[26047] = Fluid3D([9431,9340,9530,10169],0); -ELEMENTS[26048] = Fluid3D([8284,8909,8322,9587],0); -ELEMENTS[26049] = Fluid3D([5431,5844,5997,5660],0); -ELEMENTS[26050] = Fluid3D([10819,11703,11189,11026],0); -ELEMENTS[26051] = Fluid3D([10819,11703,11026,11224],0); -ELEMENTS[26052] = Fluid3D([10819,11703,11224,11581],0); -ELEMENTS[26053] = Fluid3D([11026,10819,11224,10297],0); -ELEMENTS[26054] = Fluid3D([11703,11026,11224,11539],0); -ELEMENTS[26055] = Fluid3D([11224,11703,11539,12033],0); -ELEMENTS[26056] = Fluid3D([11539,11224,12033,11092],0); -ELEMENTS[26057] = Fluid3D([11026,11224,11539,10297],0); -ELEMENTS[26058] = Fluid3D([11703,11539,12033,11935],0); -ELEMENTS[26059] = Fluid3D([11539,12033,11935,12197],0); -ELEMENTS[26060] = Fluid3D([11539,12033,12197,11270],0); -ELEMENTS[26061] = Fluid3D([11539,12033,11270,11092],0); -ELEMENTS[26062] = Fluid3D([11935,11539,12197,11031],0); -ELEMENTS[26063] = Fluid3D([11935,11539,11031,11026],0); -ELEMENTS[26064] = Fluid3D([11539,11031,11026,10297],0); -ELEMENTS[26065] = Fluid3D([11031,11026,10297,11189],0); -ELEMENTS[26066] = Fluid3D([12197,11539,11270,11031],0); -ELEMENTS[26067] = Fluid3D([11539,11270,11031,10297],0); -ELEMENTS[26068] = Fluid3D([11703,11539,11935,11026],0); -ELEMENTS[26069] = Fluid3D([11703,11224,11581,12033],0); -ELEMENTS[26070] = Fluid3D([11224,10819,11581,10675],0); -ELEMENTS[26071] = Fluid3D([11224,10819,10675,10297],0); -ELEMENTS[26072] = Fluid3D([11270,11539,11092,10297],0); -ELEMENTS[26073] = Fluid3D([11703,11189,11026,11935],0); -ELEMENTS[26074] = Fluid3D([11189,10819,11026,10297],0); -ELEMENTS[26075] = Fluid3D([10606,9678,10434,10459],0); -ELEMENTS[26076] = Fluid3D([13401,12797,12648,13414],0); -ELEMENTS[26077] = Fluid3D([12500,12935,11908,12391],0); -ELEMENTS[26078] = Fluid3D([2528,2425,2550,2207],0); -ELEMENTS[26079] = Fluid3D([16203,16423,16162,15837],0); -ELEMENTS[26080] = Fluid3D([16203,16423,15837,16155],0); -ELEMENTS[26081] = Fluid3D([16423,15837,16155,16192],0); -ELEMENTS[26082] = Fluid3D([16162,16203,15837,15695],0); -ELEMENTS[26083] = Fluid3D([15837,16162,15695,15586],0); -ELEMENTS[26084] = Fluid3D([15695,15837,15586,15197],0); -ELEMENTS[26085] = Fluid3D([15695,15837,15197,15582],0); -ELEMENTS[26086] = Fluid3D([16162,16203,15695,16316],0); -ELEMENTS[26087] = Fluid3D([15695,15837,15582,16203],0); -ELEMENTS[26088] = Fluid3D([15197,15695,15582,15119],0); -ELEMENTS[26089] = Fluid3D([15197,15695,15119,15097],0); -ELEMENTS[26090] = Fluid3D([15197,15695,15097,15586],0); -ELEMENTS[26091] = Fluid3D([15695,15119,15097,15420],0); -ELEMENTS[26092] = Fluid3D([15097,15695,15420,15767],0); -ELEMENTS[26093] = Fluid3D([15097,15695,15767,15586],0); -ELEMENTS[26094] = Fluid3D([15695,15119,15420,16174],0); -ELEMENTS[26095] = Fluid3D([15695,15582,15119,16174],0); -ELEMENTS[26096] = Fluid3D([15837,16162,15586,16046],0); -ELEMENTS[26097] = Fluid3D([16162,15586,16046,15914],0); -ELEMENTS[26098] = Fluid3D([15837,16162,16046,16423],0); -ELEMENTS[26099] = Fluid3D([15586,15837,16046,15474],0); -ELEMENTS[26100] = Fluid3D([15586,15837,15474,15197],0); -ELEMENTS[26101] = Fluid3D([15837,16046,15474,16082],0); -ELEMENTS[26102] = Fluid3D([16046,15586,15474,15638],0); -ELEMENTS[26103] = Fluid3D([16046,15474,16082,16038],0); -ELEMENTS[26104] = Fluid3D([16082,16046,16038,16567],0); -ELEMENTS[26105] = Fluid3D([15474,16082,16038,15538],0); -ELEMENTS[26106] = Fluid3D([16082,16038,15538,16459],0); -ELEMENTS[26107] = Fluid3D([16082,16038,16459,16567],0); -ELEMENTS[26108] = Fluid3D([15474,16082,15538,15455],0); -ELEMENTS[26109] = Fluid3D([15837,16046,16082,16423],0); -ELEMENTS[26110] = Fluid3D([15695,15420,15767,16316],0); -ELEMENTS[26111] = Fluid3D([15119,15097,15420,14950],0); -ELEMENTS[26112] = Fluid3D([15420,15119,14950,15336],0); -ELEMENTS[26113] = Fluid3D([15582,15197,15119,14775],0); -ELEMENTS[26114] = Fluid3D([15197,15119,14775,15097],0); -ELEMENTS[26115] = Fluid3D([15474,15837,16082,15600],0); -ELEMENTS[26116] = Fluid3D([15474,15837,15600,15197],0); -ELEMENTS[26117] = Fluid3D([16082,15474,15600,15455],0); -ELEMENTS[26118] = Fluid3D([15600,16082,15455,16192],0); -ELEMENTS[26119] = Fluid3D([15837,16082,15600,16192],0); -ELEMENTS[26120] = Fluid3D([15837,16203,16155,15582],0); -ELEMENTS[26121] = Fluid3D([15420,15097,15767,15353],0); -ELEMENTS[26122] = Fluid3D([16162,15695,15586,15767],0); -ELEMENTS[26123] = Fluid3D([16203,16423,16155,16683],0); -ELEMENTS[26124] = Fluid3D([15837,15197,15582,15600],0); -ELEMENTS[26125] = Fluid3D([11347,11091,10359,11397],0); -ELEMENTS[26126] = Fluid3D([10623,11181,10318,11363],0); -ELEMENTS[26127] = Fluid3D([11181,10318,11363,11162],0); -ELEMENTS[26128] = Fluid3D([10623,11181,11363,11739],0); -ELEMENTS[26129] = Fluid3D([10318,11363,11162,10248],0); -ELEMENTS[26130] = Fluid3D([10318,11363,10248,10074],0); -ELEMENTS[26131] = Fluid3D([10248,10318,10074,9271],0); -ELEMENTS[26132] = Fluid3D([11162,10318,10248,10206],0); -ELEMENTS[26133] = Fluid3D([10318,10248,10206,9271],0); -ELEMENTS[26134] = Fluid3D([11162,10318,10206,10706],0); -ELEMENTS[26135] = Fluid3D([10318,10623,11363,10074],0); -ELEMENTS[26136] = Fluid3D([11181,10318,11162,10706],0); -ELEMENTS[26137] = Fluid3D([11363,11181,11162,12327],0); -ELEMENTS[26138] = Fluid3D([12112,12515,11541,11851],0); -ELEMENTS[26139] = Fluid3D([11541,12112,11851,11392],0); -ELEMENTS[26140] = Fluid3D([12112,11851,11392,12696],0); -ELEMENTS[26141] = Fluid3D([12515,11541,11851,11903],0); -ELEMENTS[26142] = Fluid3D([12112,12515,11851,12746],0); -ELEMENTS[26143] = Fluid3D([12515,11851,12746,12765],0); -ELEMENTS[26144] = Fluid3D([11851,12112,12746,12696],0); -ELEMENTS[26145] = Fluid3D([12112,12515,12746,13137],0); -ELEMENTS[26146] = Fluid3D([13490,13586,13287,13955],0); -ELEMENTS[26147] = Fluid3D([6874,7560,6892,7628],0); -ELEMENTS[26148] = Fluid3D([11639,11957,11021,12025],0); -ELEMENTS[26149] = Fluid3D([5945,5482,6117,5570],0); -ELEMENTS[26150] = Fluid3D([5482,6117,5570,5622],0); -ELEMENTS[26151] = Fluid3D([3057,2995,3334,3037],0); -ELEMENTS[26152] = Fluid3D([17363,17417,17031,17431],0); -ELEMENTS[26153] = Fluid3D([17363,17417,17431,17813],0); -ELEMENTS[26154] = Fluid3D([10181,10847,10057,11007],0); -ELEMENTS[26155] = Fluid3D([10946,10228,10754,10452],0); -ELEMENTS[26156] = Fluid3D([17547,17323,17485,17756],0); -ELEMENTS[26157] = Fluid3D([13156,13232,13761,13809],0); -ELEMENTS[26158] = Fluid3D([13251,13551,14053,14065],0); -ELEMENTS[26159] = Fluid3D([14053,13251,14065,13929],0); -ELEMENTS[26160] = Fluid3D([14065,14053,13929,14809],0); -ELEMENTS[26161] = Fluid3D([14065,14053,14809,14310],0); -ELEMENTS[26162] = Fluid3D([3260,3799,3273,3497],0); -ELEMENTS[26163] = Fluid3D([3273,3260,3497,2935],0); -ELEMENTS[26164] = Fluid3D([3799,3273,3497,3949],0); -ELEMENTS[26165] = Fluid3D([3260,3799,3497,3473],0); -ELEMENTS[26166] = Fluid3D([9773,9182,8891,8737],0); -ELEMENTS[26167] = Fluid3D([8970,9225,9745,10238],0); -ELEMENTS[26168] = Fluid3D([4476,4431,4145,4744],0); -ELEMENTS[26169] = Fluid3D([4476,4431,4744,5131],0); -ELEMENTS[26170] = Fluid3D([4145,4476,4744,4383],0); -ELEMENTS[26171] = Fluid3D([4145,4476,4383,3952],0); -ELEMENTS[26172] = Fluid3D([4431,4145,4744,4516],0); -ELEMENTS[26173] = Fluid3D([4744,4145,4383,4427],0); -ELEMENTS[26174] = Fluid3D([4145,4383,4427,3986],0); -ELEMENTS[26175] = Fluid3D([4383,4427,3986,4160],0); -ELEMENTS[26176] = Fluid3D([4427,3986,4160,4169],0); -ELEMENTS[26177] = Fluid3D([3986,4160,4169,3844],0); -ELEMENTS[26178] = Fluid3D([4427,3986,4169,4089],0); -ELEMENTS[26179] = Fluid3D([4383,4744,4427,4962],0); -ELEMENTS[26180] = Fluid3D([4383,4744,4962,4634],0); -ELEMENTS[26181] = Fluid3D([3986,4160,3844,3528],0); -ELEMENTS[26182] = Fluid3D([4476,4744,4383,4634],0); -ELEMENTS[26183] = Fluid3D([15138,14842,14393,15144],0); -ELEMENTS[26184] = Fluid3D([7926,8052,7250,8006],0); -ELEMENTS[26185] = Fluid3D([7926,8052,8006,8935],0); -ELEMENTS[26186] = Fluid3D([8052,8006,8935,9013],0); -ELEMENTS[26187] = Fluid3D([8052,7250,8006,7610],0); -ELEMENTS[26188] = Fluid3D([6188,6747,5983,6307],0); -ELEMENTS[26189] = Fluid3D([5983,6188,6307,5677],0); -ELEMENTS[26190] = Fluid3D([6188,6307,5677,6127],0); -ELEMENTS[26191] = Fluid3D([6188,6307,6127,6946],0); -ELEMENTS[26192] = Fluid3D([6188,6747,6307,6946],0); -ELEMENTS[26193] = Fluid3D([6307,5677,6127,5886],0); -ELEMENTS[26194] = Fluid3D([5677,6127,5886,5483],0); -ELEMENTS[26195] = Fluid3D([6307,5677,5886,5905],0); -ELEMENTS[26196] = Fluid3D([6127,5886,5483,5968],0); -ELEMENTS[26197] = Fluid3D([6127,6307,5886,6421],0); -ELEMENTS[26198] = Fluid3D([6307,5886,6421,6162],0); -ELEMENTS[26199] = Fluid3D([5886,5483,5968,5452],0); -ELEMENTS[26200] = Fluid3D([5483,5968,5452,5350],0); -ELEMENTS[26201] = Fluid3D([5886,5483,5452,4953],0); -ELEMENTS[26202] = Fluid3D([5677,6127,5483,5637],0); -ELEMENTS[26203] = Fluid3D([5677,6127,5637,6188],0); -ELEMENTS[26204] = Fluid3D([5483,5677,5637,5107],0); -ELEMENTS[26205] = Fluid3D([6127,5483,5637,5898],0); -ELEMENTS[26206] = Fluid3D([5483,5677,5107,4953],0); -ELEMENTS[26207] = Fluid3D([5677,5637,5107,5657],0); -ELEMENTS[26208] = Fluid3D([5483,6127,5968,5898],0); -ELEMENTS[26209] = Fluid3D([5968,5483,5898,5350],0); -ELEMENTS[26210] = Fluid3D([6127,5886,5968,6421],0); -ELEMENTS[26211] = Fluid3D([5886,5968,6421,6055],0); -ELEMENTS[26212] = Fluid3D([6421,5886,6055,5801],0); -ELEMENTS[26213] = Fluid3D([6747,5983,6307,6287],0); -ELEMENTS[26214] = Fluid3D([6307,5983,5677,5905],0); -ELEMENTS[26215] = Fluid3D([5886,5677,5483,4953],0); -ELEMENTS[26216] = Fluid3D([5983,6188,5677,5657],0); -ELEMENTS[26217] = Fluid3D([5637,5483,5107,5087],0); -ELEMENTS[26218] = Fluid3D([5968,5886,5452,6055],0); -ELEMENTS[26219] = Fluid3D([7156,6446,6370,6132],0); -ELEMENTS[26220] = Fluid3D([8461,8659,7771,8339],0); -ELEMENTS[26221] = Fluid3D([8461,8659,8339,9309],0); -ELEMENTS[26222] = Fluid3D([8659,7771,8339,8057],0); -ELEMENTS[26223] = Fluid3D([8339,8659,8057,8956],0); -ELEMENTS[26224] = Fluid3D([8339,8659,8956,9309],0); -ELEMENTS[26225] = Fluid3D([8956,8339,9309,9237],0); -ELEMENTS[26226] = Fluid3D([9309,8956,9237,9547],0); -ELEMENTS[26227] = Fluid3D([8659,7771,8057,7895],0); -ELEMENTS[26228] = Fluid3D([8057,8339,8956,8213],0); -ELEMENTS[26229] = Fluid3D([8339,8956,8213,9237],0); -ELEMENTS[26230] = Fluid3D([8956,8057,8213,8484],0); -ELEMENTS[26231] = Fluid3D([8057,8213,8484,7422],0); -ELEMENTS[26232] = Fluid3D([8956,8057,8484,9080],0); -ELEMENTS[26233] = Fluid3D([8057,8339,8213,7375],0); -ELEMENTS[26234] = Fluid3D([8213,8057,7375,7422],0); -ELEMENTS[26235] = Fluid3D([8213,8956,8484,9547],0); -ELEMENTS[26236] = Fluid3D([8659,8057,8956,9080],0); -ELEMENTS[26237] = Fluid3D([7771,8339,8057,7375],0); -ELEMENTS[26238] = Fluid3D([7771,8461,8339,7942],0); -ELEMENTS[26239] = Fluid3D([8461,8339,7942,8475],0); -ELEMENTS[26240] = Fluid3D([7942,8461,8475,7908],0); -ELEMENTS[26241] = Fluid3D([8339,7942,8475,7845],0); -ELEMENTS[26242] = Fluid3D([7771,8461,7942,7780],0); -ELEMENTS[26243] = Fluid3D([8461,7942,7780,7908],0); -ELEMENTS[26244] = Fluid3D([8339,7942,7845,7771],0); -ELEMENTS[26245] = Fluid3D([8461,8339,8475,9309],0); -ELEMENTS[26246] = Fluid3D([8475,8339,7845,8955],0); -ELEMENTS[26247] = Fluid3D([7942,7780,7908,7109],0); -ELEMENTS[26248] = Fluid3D([7942,8475,7845,7365],0); -ELEMENTS[26249] = Fluid3D([7942,7771,7780,7254],0); -ELEMENTS[26250] = Fluid3D([7942,7771,7254,7845],0); -ELEMENTS[26251] = Fluid3D([7942,8475,7365,7712],0); -ELEMENTS[26252] = Fluid3D([7942,8475,7712,7908],0); -ELEMENTS[26253] = Fluid3D([12681,13110,13366,13775],0); -ELEMENTS[26254] = Fluid3D([14861,15247,15217,14430],0); -ELEMENTS[26255] = Fluid3D([9478,8916,8686,9477],0); -ELEMENTS[26256] = Fluid3D([6353,5816,5744,6728],0); -ELEMENTS[26257] = Fluid3D([9796,10631,10233,10729],0); -ELEMENTS[26258] = Fluid3D([9796,10631,10729,10384],0); -ELEMENTS[26259] = Fluid3D([10631,10233,10729,11407],0); -ELEMENTS[26260] = Fluid3D([10233,9796,10729,9885],0); -ELEMENTS[26261] = Fluid3D([9796,10729,9885,10338],0); -ELEMENTS[26262] = Fluid3D([9796,10729,10338,10384],0); -ELEMENTS[26263] = Fluid3D([10729,9885,10338,10765],0); -ELEMENTS[26264] = Fluid3D([10338,10729,10765,11292],0); -ELEMENTS[26265] = Fluid3D([10338,10729,11292,10384],0); -ELEMENTS[26266] = Fluid3D([10729,9885,10765,10810],0); -ELEMENTS[26267] = Fluid3D([10765,10729,10810,11605],0); -ELEMENTS[26268] = Fluid3D([10765,10729,11605,11292],0); -ELEMENTS[26269] = Fluid3D([10729,11605,11292,11407],0); -ELEMENTS[26270] = Fluid3D([10729,10810,11605,11407],0); -ELEMENTS[26271] = Fluid3D([10810,10765,11605,11928],0); -ELEMENTS[26272] = Fluid3D([11605,10810,11928,11973],0); -ELEMENTS[26273] = Fluid3D([11928,11605,11973,12418],0); -ELEMENTS[26274] = Fluid3D([11928,11605,12418,11775],0); -ELEMENTS[26275] = Fluid3D([10729,9885,10810,10233],0); -ELEMENTS[26276] = Fluid3D([10810,10729,10233,11407],0); -ELEMENTS[26277] = Fluid3D([9885,10810,10233,10096],0); -ELEMENTS[26278] = Fluid3D([10233,9796,9885,9231],0); -ELEMENTS[26279] = Fluid3D([15517,15536,15622,15131],0); -ELEMENTS[26280] = Fluid3D([15622,15517,15131,15473],0); -ELEMENTS[26281] = Fluid3D([10959,10338,11292,10384],0); -ELEMENTS[26282] = Fluid3D([4668,4683,5132,4801],0); -ELEMENTS[26283] = Fluid3D([8742,8489,7722,9391],0); -ELEMENTS[26284] = Fluid3D([9169,9535,8672,8844],0); -ELEMENTS[26285] = Fluid3D([16208,15838,16422,16190],0); -ELEMENTS[26286] = Fluid3D([15567,15645,15318,15014],0); -ELEMENTS[26287] = Fluid3D([15645,15318,15014,14486],0); -ELEMENTS[26288] = Fluid3D([15567,15645,15014,15515],0); -ELEMENTS[26289] = Fluid3D([15318,15567,15014,14500],0); -ELEMENTS[26290] = Fluid3D([14790,14015,14138,14023],0); -ELEMENTS[26291] = Fluid3D([3801,3988,3808,4204],0); -ELEMENTS[26292] = Fluid3D([4262,4439,4029,3871],0); -ELEMENTS[26293] = Fluid3D([4439,4029,3871,4092],0); -ELEMENTS[26294] = Fluid3D([4029,4262,3871,3843],0); -ELEMENTS[26295] = Fluid3D([4765,5138,4975,5166],0); -ELEMENTS[26296] = Fluid3D([4975,4765,5166,4601],0); -ELEMENTS[26297] = Fluid3D([4765,5138,5166,5409],0); -ELEMENTS[26298] = Fluid3D([5138,4975,5166,5622],0); -ELEMENTS[26299] = Fluid3D([8957,9390,8533,9327],0); -ELEMENTS[26300] = Fluid3D([8533,8957,9327,8731],0); -ELEMENTS[26301] = Fluid3D([9390,8533,9327,9229],0); -ELEMENTS[26302] = Fluid3D([9390,8533,9229,8800],0); -ELEMENTS[26303] = Fluid3D([9327,9390,9229,10337],0); -ELEMENTS[26304] = Fluid3D([8957,9390,9327,10015],0); -ELEMENTS[26305] = Fluid3D([8533,9327,9229,8325],0); -ELEMENTS[26306] = Fluid3D([14495,13901,13593,13948],0); -ELEMENTS[26307] = Fluid3D([13901,13593,13948,13146],0); -ELEMENTS[26308] = Fluid3D([17574,17750,17779,17536],0); -ELEMENTS[26309] = Fluid3D([9817,9854,10640,9593],0); -ELEMENTS[26310] = Fluid3D([8329,9647,8808,9102],0); -ELEMENTS[26311] = Fluid3D([4206,4017,3688,3829],0); -ELEMENTS[26312] = Fluid3D([18014,17841,17798,17512],0); -ELEMENTS[26313] = Fluid3D([14806,15302,14876,14836],0); -ELEMENTS[26314] = Fluid3D([14876,14806,14836,14233],0); -ELEMENTS[26315] = Fluid3D([14836,14876,14233,15060],0); -ELEMENTS[26316] = Fluid3D([15302,14876,14836,15060],0); -ELEMENTS[26317] = Fluid3D([14806,15302,14836,14965],0); -ELEMENTS[26318] = Fluid3D([15302,14836,14965,15060],0); -ELEMENTS[26319] = Fluid3D([14836,14965,15060,14214],0); -ELEMENTS[26320] = Fluid3D([14836,14965,14214,14361],0); -ELEMENTS[26321] = Fluid3D([15060,14836,14214,14233],0); -ELEMENTS[26322] = Fluid3D([14836,14214,14233,14806],0); -ELEMENTS[26323] = Fluid3D([14836,14965,14361,14806],0); -ELEMENTS[26324] = Fluid3D([14309,13564,13871,14230],0); -ELEMENTS[26325] = Fluid3D([14309,13564,14230,14252],0); -ELEMENTS[26326] = Fluid3D([13564,13871,14230,13407],0); -ELEMENTS[26327] = Fluid3D([13564,13871,13407,12883],0); -ELEMENTS[26328] = Fluid3D([14230,13564,13407,14020],0); -ELEMENTS[26329] = Fluid3D([13407,14230,14020,14660],0); -ELEMENTS[26330] = Fluid3D([13871,14230,13407,14048],0); -ELEMENTS[26331] = Fluid3D([13407,13871,14048,12837],0); -ELEMENTS[26332] = Fluid3D([13871,14230,14048,14576],0); -ELEMENTS[26333] = Fluid3D([14230,13407,14048,14660],0); -ELEMENTS[26334] = Fluid3D([14230,14048,14576,14660],0); -ELEMENTS[26335] = Fluid3D([13871,14309,14230,14576],0); -ELEMENTS[26336] = Fluid3D([14048,13871,14576,14161],0); -ELEMENTS[26337] = Fluid3D([16469,16959,16803,16218],0); -ELEMENTS[26338] = Fluid3D([13869,13238,13227,13416],0); -ELEMENTS[26339] = Fluid3D([13227,13869,13416,13365],0); -ELEMENTS[26340] = Fluid3D([13416,13227,13365,12532],0); -ELEMENTS[26341] = Fluid3D([13365,13416,12532,13301],0); -ELEMENTS[26342] = Fluid3D([13365,13416,13301,13869],0); -ELEMENTS[26343] = Fluid3D([13416,13227,12532,12176],0); -ELEMENTS[26344] = Fluid3D([13227,13365,12532,12814],0); -ELEMENTS[26345] = Fluid3D([13365,12532,12814,12857],0); -ELEMENTS[26346] = Fluid3D([12814,13365,12857,13327],0); -ELEMENTS[26347] = Fluid3D([12857,12814,13327,13217],0); -ELEMENTS[26348] = Fluid3D([12814,13365,13327,13227],0); -ELEMENTS[26349] = Fluid3D([13327,12814,13227,13100],0); -ELEMENTS[26350] = Fluid3D([13365,12532,12857,12430],0); -ELEMENTS[26351] = Fluid3D([13365,12857,13327,13836],0); -ELEMENTS[26352] = Fluid3D([12814,13327,13217,13154],0); -ELEMENTS[26353] = Fluid3D([12814,13327,13154,13100],0); -ELEMENTS[26354] = Fluid3D([13327,13217,13154,13836],0); -ELEMENTS[26355] = Fluid3D([13154,13327,13836,13906],0); -ELEMENTS[26356] = Fluid3D([13154,13327,13906,13100],0); -ELEMENTS[26357] = Fluid3D([12532,12814,12857,12269],0); -ELEMENTS[26358] = Fluid3D([12814,12857,12269,13217],0); -ELEMENTS[26359] = Fluid3D([12532,12814,12269,12009],0); -ELEMENTS[26360] = Fluid3D([12814,12269,12009,12064],0); -ELEMENTS[26361] = Fluid3D([12532,12814,12009,13227],0); -ELEMENTS[26362] = Fluid3D([13869,13238,13416,14273],0); -ELEMENTS[26363] = Fluid3D([13238,13227,13416,12176],0); -ELEMENTS[26364] = Fluid3D([14936,14181,14834,14439],0); -ELEMENTS[26365] = Fluid3D([14181,14834,14439,13740],0); -ELEMENTS[26366] = Fluid3D([4193,4052,4203,4756],0); -ELEMENTS[26367] = Fluid3D([3216,3288,3625,3245],0); -ELEMENTS[26368] = Fluid3D([17217,16865,17221,17333],0); -ELEMENTS[26369] = Fluid3D([11105,10528,11020,9781],0); -ELEMENTS[26370] = Fluid3D([11132,12110,11613,11622],0); -ELEMENTS[26371] = Fluid3D([11613,11132,11622,10681],0); -ELEMENTS[26372] = Fluid3D([11132,11622,10681,10920],0); -ELEMENTS[26373] = Fluid3D([11622,11613,10681,11747],0); -ELEMENTS[26374] = Fluid3D([12110,11613,11622,12816],0); -ELEMENTS[26375] = Fluid3D([11132,12110,11622,11699],0); -ELEMENTS[26376] = Fluid3D([14408,15135,14811,14254],0); -ELEMENTS[26377] = Fluid3D([8359,8574,8302,9216],0); -ELEMENTS[26378] = Fluid3D([6556,7365,6719,6879],0); -ELEMENTS[26379] = Fluid3D([7842,7916,7472,7115],0); -ELEMENTS[26380] = Fluid3D([7472,7842,7115,6669],0); -ELEMENTS[26381] = Fluid3D([7916,7472,7115,6935],0); -ELEMENTS[26382] = Fluid3D([7842,7916,7115,7910],0); -ELEMENTS[26383] = Fluid3D([14465,13773,14355,14206],0); -ELEMENTS[26384] = Fluid3D([14355,14465,14206,15047],0); -ELEMENTS[26385] = Fluid3D([13773,14355,14206,13959],0); -ELEMENTS[26386] = Fluid3D([14465,13773,14206,13870],0); -ELEMENTS[26387] = Fluid3D([14465,13773,13870,13855],0); -ELEMENTS[26388] = Fluid3D([13870,14465,13855,14322],0); -ELEMENTS[26389] = Fluid3D([14206,14465,13870,14462],0); -ELEMENTS[26390] = Fluid3D([14465,13870,14462,14322],0); -ELEMENTS[26391] = Fluid3D([14206,14465,14462,15047],0); -ELEMENTS[26392] = Fluid3D([6340,5753,5784,5687],0); -ELEMENTS[26393] = Fluid3D([5784,6340,5687,6492],0); -ELEMENTS[26394] = Fluid3D([5753,5784,5687,5285],0); -ELEMENTS[26395] = Fluid3D([6340,5687,6492,6657],0); -ELEMENTS[26396] = Fluid3D([6492,6340,6657,7121],0); -ELEMENTS[26397] = Fluid3D([6492,6340,7121,6652],0); -ELEMENTS[26398] = Fluid3D([7121,6492,6652,7286],0); -ELEMENTS[26399] = Fluid3D([6652,7121,7286,6952],0); -ELEMENTS[26400] = Fluid3D([6657,6492,7121,7429],0); -ELEMENTS[26401] = Fluid3D([6492,7121,7429,7240],0); -ELEMENTS[26402] = Fluid3D([6492,7121,7240,7286],0); -ELEMENTS[26403] = Fluid3D([7121,7240,7286,7932],0); -ELEMENTS[26404] = Fluid3D([7240,7286,7932,7816],0); -ELEMENTS[26405] = Fluid3D([7240,7286,7816,7044],0); -ELEMENTS[26406] = Fluid3D([7932,7240,7816,8008],0); -ELEMENTS[26407] = Fluid3D([7121,7240,7932,7429],0); -ELEMENTS[26408] = Fluid3D([7429,6492,7240,7187],0); -ELEMENTS[26409] = Fluid3D([6492,6340,6652,5784],0); -ELEMENTS[26410] = Fluid3D([7286,7932,7816,7919],0); -ELEMENTS[26411] = Fluid3D([7286,7932,7919,7121],0); -ELEMENTS[26412] = Fluid3D([7121,6657,7429,7519],0); -ELEMENTS[26413] = Fluid3D([7932,7240,8008,7429],0); -ELEMENTS[26414] = Fluid3D([9958,9406,10426,9533],0); -ELEMENTS[26415] = Fluid3D([5378,5600,5249,5950],0); -ELEMENTS[26416] = Fluid3D([11594,12377,12212,12097],0); -ELEMENTS[26417] = Fluid3D([15282,14567,14874,15151],0); -ELEMENTS[26418] = Fluid3D([15282,14567,15151,15447],0); -ELEMENTS[26419] = Fluid3D([9307,9095,8397,8850],0); -ELEMENTS[26420] = Fluid3D([16452,16339,16760,16029],0); -ELEMENTS[26421] = Fluid3D([14394,14890,15041,14666],0); -ELEMENTS[26422] = Fluid3D([14890,15041,14666,15488],0); -ELEMENTS[26423] = Fluid3D([14394,14890,14666,13981],0); -ELEMENTS[26424] = Fluid3D([14890,14666,13981,14363],0); -ELEMENTS[26425] = Fluid3D([14666,14890,15488,15370],0); -ELEMENTS[26426] = Fluid3D([15041,14394,14666,14294],0); -ELEMENTS[26427] = Fluid3D([14666,15041,14294,15124],0); -ELEMENTS[26428] = Fluid3D([14666,15041,15124,15488],0); -ELEMENTS[26429] = Fluid3D([15996,16474,15984,16252],0); -ELEMENTS[26430] = Fluid3D([16474,15984,16252,16674],0); -ELEMENTS[26431] = Fluid3D([15996,16474,16252,16468],0); -ELEMENTS[26432] = Fluid3D([15984,15996,16252,15473],0); -ELEMENTS[26433] = Fluid3D([13697,12986,12987,12845],0); -ELEMENTS[26434] = Fluid3D([6004,6037,6949,6137],0); -ELEMENTS[26435] = Fluid3D([8009,7356,7318,7713],0); -ELEMENTS[26436] = Fluid3D([7356,7318,7713,6893],0); -ELEMENTS[26437] = Fluid3D([8009,7356,7713,8163],0); -ELEMENTS[26438] = Fluid3D([7318,8009,7713,7982],0); -ELEMENTS[26439] = Fluid3D([7713,7318,7982,7491],0); -ELEMENTS[26440] = Fluid3D([7318,7982,7491,7509],0); -ELEMENTS[26441] = Fluid3D([7318,7982,7509,8009],0); -ELEMENTS[26442] = Fluid3D([7713,7318,7491,6893],0); -ELEMENTS[26443] = Fluid3D([7982,7713,7491,7898],0); -ELEMENTS[26444] = Fluid3D([7491,7982,7898,7509],0); -ELEMENTS[26445] = Fluid3D([7982,7898,7509,8552],0); -ELEMENTS[26446] = Fluid3D([7982,7898,8552,8685],0); -ELEMENTS[26447] = Fluid3D([7491,7318,7509,6461],0); -ELEMENTS[26448] = Fluid3D([7491,7318,6461,6893],0); -ELEMENTS[26449] = Fluid3D([7318,7509,6461,6771],0); -ELEMENTS[26450] = Fluid3D([6461,7318,6771,7105],0); -ELEMENTS[26451] = Fluid3D([8009,7713,7982,8540],0); -ELEMENTS[26452] = Fluid3D([7982,8009,8540,8500],0); -ELEMENTS[26453] = Fluid3D([7982,8009,8500,7509],0); -ELEMENTS[26454] = Fluid3D([8500,7982,7509,8552],0); -ELEMENTS[26455] = Fluid3D([8500,7982,8552,8685],0); -ELEMENTS[26456] = Fluid3D([8540,7982,8500,9476],0); -ELEMENTS[26457] = Fluid3D([8009,8540,8500,9504],0); -ELEMENTS[26458] = Fluid3D([8009,7713,8540,8163],0); -ELEMENTS[26459] = Fluid3D([7713,7982,8540,8220],0); -ELEMENTS[26460] = Fluid3D([8540,7713,8220,8163],0); -ELEMENTS[26461] = Fluid3D([1977,1997,1888,1869],0); -ELEMENTS[26462] = Fluid3D([1888,1977,1869,1808],0); -ELEMENTS[26463] = Fluid3D([1977,1997,1869,2083],0); -ELEMENTS[26464] = Fluid3D([1977,1869,1808,1873],0); -ELEMENTS[26465] = Fluid3D([1977,1869,1873,2083],0); -ELEMENTS[26466] = Fluid3D([1808,1977,1873,1829],0); -ELEMENTS[26467] = Fluid3D([1869,1808,1873,1712],0); -ELEMENTS[26468] = Fluid3D([1873,1869,1712,1791],0); -ELEMENTS[26469] = Fluid3D([1712,1873,1791,1698],0); -ELEMENTS[26470] = Fluid3D([1869,1808,1712,1727],0); -ELEMENTS[26471] = Fluid3D([1808,1712,1727,1639],0); -ELEMENTS[26472] = Fluid3D([1712,1727,1639,1641],0); -ELEMENTS[26473] = Fluid3D([1869,1808,1727,1888],0); -ELEMENTS[26474] = Fluid3D([1873,1869,1791,1956],0); -ELEMENTS[26475] = Fluid3D([1873,1869,1956,2083],0); -ELEMENTS[26476] = Fluid3D([1791,1873,1956,1915],0); -ELEMENTS[26477] = Fluid3D([1869,1791,1956,1861],0); -ELEMENTS[26478] = Fluid3D([1873,1956,1915,2083],0); -ELEMENTS[26479] = Fluid3D([1869,1791,1861,1723],0); -ELEMENTS[26480] = Fluid3D([1869,1791,1723,1712],0); -ELEMENTS[26481] = Fluid3D([1861,1869,1723,1831],0); -ELEMENTS[26482] = Fluid3D([1861,1869,1831,1997],0); -ELEMENTS[26483] = Fluid3D([1791,1861,1723,1744],0); -ELEMENTS[26484] = Fluid3D([1791,1861,1744,1880],0); -ELEMENTS[26485] = Fluid3D([1791,1861,1880,1956],0); -ELEMENTS[26486] = Fluid3D([1723,1861,1831,1717],0); -ELEMENTS[26487] = Fluid3D([1861,1723,1744,1717],0); -ELEMENTS[26488] = Fluid3D([1723,1744,1717,1625],0); -ELEMENTS[26489] = Fluid3D([1808,1873,1712,1715],0); -ELEMENTS[26490] = Fluid3D([1712,1808,1715,1639],0); -ELEMENTS[26491] = Fluid3D([1715,1712,1639,1621],0); -ELEMENTS[26492] = Fluid3D([1715,1712,1621,1698],0); -ELEMENTS[26493] = Fluid3D([1873,1712,1715,1698],0); -ELEMENTS[26494] = Fluid3D([1712,1639,1621,1641],0); -ELEMENTS[26495] = Fluid3D([1791,1873,1915,1698],0); -ELEMENTS[26496] = Fluid3D([1861,1744,1880,1875],0); -ELEMENTS[26497] = Fluid3D([1744,1880,1875,1818],0); -ELEMENTS[26498] = Fluid3D([1861,1744,1875,1717],0); -ELEMENTS[26499] = Fluid3D([1880,1875,1818,2087],0); -ELEMENTS[26500] = Fluid3D([1880,1861,1875,2098],0); -ELEMENTS[26501] = Fluid3D([1744,1880,1818,1759],0); -ELEMENTS[26502] = Fluid3D([1744,1880,1759,1791],0); -ELEMENTS[26503] = Fluid3D([1880,1818,1759,1878],0); -ELEMENTS[26504] = Fluid3D([1818,1744,1759,1613],0); -ELEMENTS[26505] = Fluid3D([1818,1759,1878,1746],0); -ELEMENTS[26506] = Fluid3D([1880,1818,1878,2087],0); -ELEMENTS[26507] = Fluid3D([1759,1880,1878,1915],0); -ELEMENTS[26508] = Fluid3D([1875,1744,1818,1711],0); -ELEMENTS[26509] = Fluid3D([1744,1818,1711,1613],0); -ELEMENTS[26510] = Fluid3D([1997,1888,1869,1831],0); -ELEMENTS[26511] = Fluid3D([1712,1869,1727,1723],0); -ELEMENTS[26512] = Fluid3D([1956,1791,1915,1880],0); -ELEMENTS[26513] = Fluid3D([1723,1791,1744,1625],0); -ELEMENTS[26514] = Fluid3D([1888,1977,1808,1966],0); -ELEMENTS[26515] = Fluid3D([1956,1869,1861,1997],0); -ELEMENTS[26516] = Fluid3D([1869,1723,1831,1727],0); -ELEMENTS[26517] = Fluid3D([8606,9421,9338,8821],0); -ELEMENTS[26518] = Fluid3D([9338,8606,8821,8331],0); -ELEMENTS[26519] = Fluid3D([8606,8821,8331,8494],0); -ELEMENTS[26520] = Fluid3D([8606,9421,8821,8494],0); -ELEMENTS[26521] = Fluid3D([9421,9338,8821,9799],0); -ELEMENTS[26522] = Fluid3D([9338,8821,9799,9219],0); -ELEMENTS[26523] = Fluid3D([8821,9421,9799,9225],0); -ELEMENTS[26524] = Fluid3D([8821,9799,9219,8658],0); -ELEMENTS[26525] = Fluid3D([9219,8821,8658,8331],0); -ELEMENTS[26526] = Fluid3D([8821,8658,8331,8378],0); -ELEMENTS[26527] = Fluid3D([8821,8658,8378,9225],0); -ELEMENTS[26528] = Fluid3D([8821,8658,9225,9799],0); -ELEMENTS[26529] = Fluid3D([9421,9338,9799,10264],0); -ELEMENTS[26530] = Fluid3D([9338,8821,9219,8331],0); -ELEMENTS[26531] = Fluid3D([9799,9338,9219,9885],0); -ELEMENTS[26532] = Fluid3D([17141,16704,17140,16950],0); -ELEMENTS[26533] = Fluid3D([17141,16704,16950,16619],0); -ELEMENTS[26534] = Fluid3D([17140,17141,16950,17430],0); -ELEMENTS[26535] = Fluid3D([17140,17141,17430,17536],0); -ELEMENTS[26536] = Fluid3D([17141,17430,17536,17626],0); -ELEMENTS[26537] = Fluid3D([17430,17140,17536,17452],0); -ELEMENTS[26538] = Fluid3D([16704,17140,16950,16705],0); -ELEMENTS[26539] = Fluid3D([10852,11488,10400,10504],0); -ELEMENTS[26540] = Fluid3D([8589,8593,7820,8188],0); -ELEMENTS[26541] = Fluid3D([15713,15215,15742,15690],0); -ELEMENTS[26542] = Fluid3D([15612,14916,15341,15530],0); -ELEMENTS[26543] = Fluid3D([16886,16450,16783,16246],0); -ELEMENTS[26544] = Fluid3D([3140,3018,2844,2699],0); -ELEMENTS[26545] = Fluid3D([13298,13456,14157,13917],0); -ELEMENTS[26546] = Fluid3D([5704,5694,5592,6516],0); -ELEMENTS[26547] = Fluid3D([7943,7594,8426,7607],0); -ELEMENTS[26548] = Fluid3D([13016,13515,13965,13880],0); -ELEMENTS[26549] = Fluid3D([14299,13528,14023,13554],0); -ELEMENTS[26550] = Fluid3D([14299,13528,13554,13698],0); -ELEMENTS[26551] = Fluid3D([13528,14023,13554,13118],0); -ELEMENTS[26552] = Fluid3D([4490,4543,4811,4206],0); -ELEMENTS[26553] = Fluid3D([10908,9770,10403,11256],0); -ELEMENTS[26554] = Fluid3D([17450,17068,17216,17501],0); -ELEMENTS[26555] = Fluid3D([12805,12385,11856,12664],0); -ELEMENTS[26556] = Fluid3D([9201,10121,9904,9105],0); -ELEMENTS[26557] = Fluid3D([14010,13252,13281,13762],0); -ELEMENTS[26558] = Fluid3D([13281,14010,13762,13870],0); -ELEMENTS[26559] = Fluid3D([7148,6368,6761,7147],0); -ELEMENTS[26560] = Fluid3D([9061,8650,8132,9117],0); -ELEMENTS[26561] = Fluid3D([9252,8341,9057,9103],0); -ELEMENTS[26562] = Fluid3D([10119,10556,11159,10867],0); -ELEMENTS[26563] = Fluid3D([16897,16481,16379,16806],0); -ELEMENTS[26564] = Fluid3D([5150,5350,4720,4822],0); -ELEMENTS[26565] = Fluid3D([4720,5150,4822,4734],0); -ELEMENTS[26566] = Fluid3D([5150,5350,4822,5360],0); -ELEMENTS[26567] = Fluid3D([4822,5150,5360,4957],0); -ELEMENTS[26568] = Fluid3D([4822,5150,4957,4734],0); -ELEMENTS[26569] = Fluid3D([5360,4822,4957,4922],0); -ELEMENTS[26570] = Fluid3D([4822,4957,4922,4306],0); -ELEMENTS[26571] = Fluid3D([5360,4822,4922,5086],0); -ELEMENTS[26572] = Fluid3D([5360,4822,5086,5350],0); -ELEMENTS[26573] = Fluid3D([4922,5360,5086,5469],0); -ELEMENTS[26574] = Fluid3D([5086,4922,5469,4892],0); -ELEMENTS[26575] = Fluid3D([5150,5350,5360,5756],0); -ELEMENTS[26576] = Fluid3D([4822,4922,5086,4357],0); -ELEMENTS[26577] = Fluid3D([4922,5360,5469,5349],0); -ELEMENTS[26578] = Fluid3D([5360,5469,5349,5926],0); -ELEMENTS[26579] = Fluid3D([4922,5360,5349,4957],0); -ELEMENTS[26580] = Fluid3D([5469,4922,5349,5159],0); -ELEMENTS[26581] = Fluid3D([4922,5349,5159,4940],0); -ELEMENTS[26582] = Fluid3D([5469,4922,5159,4892],0); -ELEMENTS[26583] = Fluid3D([5349,5469,5159,5667],0); -ELEMENTS[26584] = Fluid3D([5349,5469,5667,5926],0); -ELEMENTS[26585] = Fluid3D([5469,5159,5667,5146],0); -ELEMENTS[26586] = Fluid3D([5159,5349,5667,5450],0); -ELEMENTS[26587] = Fluid3D([5159,5349,5450,4940],0); -ELEMENTS[26588] = Fluid3D([5349,5450,4940,5542],0); -ELEMENTS[26589] = Fluid3D([5450,5159,4940,4948],0); -ELEMENTS[26590] = Fluid3D([5349,5450,5542,5885],0); -ELEMENTS[26591] = Fluid3D([5349,5667,5450,5885],0); -ELEMENTS[26592] = Fluid3D([5150,5360,4957,5256],0); -ELEMENTS[26593] = Fluid3D([4957,5150,5256,4734],0); -ELEMENTS[26594] = Fluid3D([5150,5360,5256,5756],0); -ELEMENTS[26595] = Fluid3D([5256,5150,5756,5574],0); -ELEMENTS[26596] = Fluid3D([5256,5150,5574,4734],0); -ELEMENTS[26597] = Fluid3D([5350,4720,4822,4710],0); -ELEMENTS[26598] = Fluid3D([4720,4822,4710,4297],0); -ELEMENTS[26599] = Fluid3D([4710,4720,4297,4294],0); -ELEMENTS[26600] = Fluid3D([4297,4710,4294,4122],0); -ELEMENTS[26601] = Fluid3D([4297,4710,4122,4822],0); -ELEMENTS[26602] = Fluid3D([5350,4720,4710,5087],0); -ELEMENTS[26603] = Fluid3D([4710,4720,4294,5087],0); -ELEMENTS[26604] = Fluid3D([4822,5350,4710,5086],0); -ELEMENTS[26605] = Fluid3D([4720,4822,4297,4499],0); -ELEMENTS[26606] = Fluid3D([4720,4822,4499,4734],0); -ELEMENTS[26607] = Fluid3D([4499,4720,4734,4281],0); -ELEMENTS[26608] = Fluid3D([4734,4499,4281,3965],0); -ELEMENTS[26609] = Fluid3D([4734,4499,3965,4776],0); -ELEMENTS[26610] = Fluid3D([4734,4499,4776,4957],0); -ELEMENTS[26611] = Fluid3D([4499,4720,4281,4297],0); -ELEMENTS[26612] = Fluid3D([4281,4499,4297,3965],0); -ELEMENTS[26613] = Fluid3D([4822,4297,4499,4308],0); -ELEMENTS[26614] = Fluid3D([4822,4297,4308,4357],0); -ELEMENTS[26615] = Fluid3D([4297,4499,4308,3965],0); -ELEMENTS[26616] = Fluid3D([4499,4308,3965,4306],0); -ELEMENTS[26617] = Fluid3D([4308,3965,4306,3886],0); -ELEMENTS[26618] = Fluid3D([4720,4297,4294,4281],0); -ELEMENTS[26619] = Fluid3D([4499,4822,4308,4306],0); -ELEMENTS[26620] = Fluid3D([5360,5086,5469,5926],0); -ELEMENTS[26621] = Fluid3D([12010,11406,12280,11259],0); -ELEMENTS[26622] = Fluid3D([11776,10894,11704,11432],0); -ELEMENTS[26623] = Fluid3D([17452,17746,17535,17394],0); -ELEMENTS[26624] = Fluid3D([12731,12118,13000,12450],0); -ELEMENTS[26625] = Fluid3D([4345,4660,4229,4185],0); -ELEMENTS[26626] = Fluid3D([5729,6255,5624,5529],0); -ELEMENTS[26627] = Fluid3D([8050,7524,7329,7226],0); -ELEMENTS[26628] = Fluid3D([8050,7524,7226,7950],0); -ELEMENTS[26629] = Fluid3D([7524,7329,7226,6689],0); -ELEMENTS[26630] = Fluid3D([7524,7329,6689,7517],0); -ELEMENTS[26631] = Fluid3D([7226,7524,6689,6958],0); -ELEMENTS[26632] = Fluid3D([7226,7524,6958,7950],0); -ELEMENTS[26633] = Fluid3D([7524,6689,6958,6901],0); -ELEMENTS[26634] = Fluid3D([6689,6958,6901,5978],0); -ELEMENTS[26635] = Fluid3D([6958,7524,6901,7354],0); -ELEMENTS[26636] = Fluid3D([7524,6689,6901,7517],0); -ELEMENTS[26637] = Fluid3D([7329,8050,7226,7559],0); -ELEMENTS[26638] = Fluid3D([7226,7329,7559,6718],0); -ELEMENTS[26639] = Fluid3D([7329,7559,6718,7005],0); -ELEMENTS[26640] = Fluid3D([8050,7226,7559,7883],0); -ELEMENTS[26641] = Fluid3D([7329,8050,7559,8250],0); -ELEMENTS[26642] = Fluid3D([7559,8050,7883,8795],0); -ELEMENTS[26643] = Fluid3D([8050,7226,7883,7950],0); -ELEMENTS[26644] = Fluid3D([7226,7559,7883,7319],0); -ELEMENTS[26645] = Fluid3D([7559,7883,7319,8492],0); -ELEMENTS[26646] = Fluid3D([7559,7226,6718,7319],0); -ELEMENTS[26647] = Fluid3D([7226,7329,6718,6689],0); -ELEMENTS[26648] = Fluid3D([6689,7226,6958,6526],0); -ELEMENTS[26649] = Fluid3D([7226,6958,6526,7052],0); -ELEMENTS[26650] = Fluid3D([6958,6526,7052,6393],0); -ELEMENTS[26651] = Fluid3D([6958,6526,6393,5978],0); -ELEMENTS[26652] = Fluid3D([6526,7052,6393,6218],0); -ELEMENTS[26653] = Fluid3D([6393,6526,6218,5719],0); -ELEMENTS[26654] = Fluid3D([6526,7052,6218,6951],0); -ELEMENTS[26655] = Fluid3D([7052,6218,6951,6636],0); -ELEMENTS[26656] = Fluid3D([7052,6393,6218,6636],0); -ELEMENTS[26657] = Fluid3D([6689,7226,6526,6718],0); -ELEMENTS[26658] = Fluid3D([7052,6958,6393,7197],0); -ELEMENTS[26659] = Fluid3D([7052,6958,7197,7950],0); -ELEMENTS[26660] = Fluid3D([6958,6393,7197,6661],0); -ELEMENTS[26661] = Fluid3D([6393,7052,7197,6636],0); -ELEMENTS[26662] = Fluid3D([6958,6393,6661,5978],0); -ELEMENTS[26663] = Fluid3D([6393,7197,6661,6306],0); -ELEMENTS[26664] = Fluid3D([7226,6958,7052,7950],0); -ELEMENTS[26665] = Fluid3D([6526,7226,7052,6951],0); -ELEMENTS[26666] = Fluid3D([6958,6689,6526,5978],0); -ELEMENTS[26667] = Fluid3D([7197,6958,6661,7354],0); -ELEMENTS[26668] = Fluid3D([8049,7376,7690,7962],0); -ELEMENTS[26669] = Fluid3D([12500,12472,12673,11709],0); -ELEMENTS[26670] = Fluid3D([14390,14437,15093,14697],0); -ELEMENTS[26671] = Fluid3D([15093,14390,14697,15108],0); -ELEMENTS[26672] = Fluid3D([14390,14437,14697,14226],0); -ELEMENTS[26673] = Fluid3D([14437,15093,14697,15360],0); -ELEMENTS[26674] = Fluid3D([14697,15093,15108,15360],0); -ELEMENTS[26675] = Fluid3D([7897,7854,7106,7113],0); -ELEMENTS[26676] = Fluid3D([17385,17126,17378,17511],0); -ELEMENTS[26677] = Fluid3D([5787,5897,6667,5849],0); -ELEMENTS[26678] = Fluid3D([5787,5897,5849,5377],0); -ELEMENTS[26679] = Fluid3D([6667,5787,5849,6192],0); -ELEMENTS[26680] = Fluid3D([5897,5849,5377,5515],0); -ELEMENTS[26681] = Fluid3D([5897,5849,5515,5986],0); -ELEMENTS[26682] = Fluid3D([5377,5897,5515,5239],0); -ELEMENTS[26683] = Fluid3D([5897,5515,5239,5765],0); -ELEMENTS[26684] = Fluid3D([5377,5897,5239,5713],0); -ELEMENTS[26685] = Fluid3D([5849,5377,5515,4934],0); -ELEMENTS[26686] = Fluid3D([5377,5515,4934,4962],0); -ELEMENTS[26687] = Fluid3D([4934,5377,4962,4666],0); -ELEMENTS[26688] = Fluid3D([5515,4934,4962,5098],0); -ELEMENTS[26689] = Fluid3D([4934,4962,5098,4634],0); -ELEMENTS[26690] = Fluid3D([4962,5515,5098,5074],0); -ELEMENTS[26691] = Fluid3D([4962,5515,5074,5168],0); -ELEMENTS[26692] = Fluid3D([4962,5515,5168,5239],0); -ELEMENTS[26693] = Fluid3D([5515,5168,5239,5765],0); -ELEMENTS[26694] = Fluid3D([5168,4962,5239,4672],0); -ELEMENTS[26695] = Fluid3D([5168,5239,5765,5093],0); -ELEMENTS[26696] = Fluid3D([5168,5239,5093,4672],0); -ELEMENTS[26697] = Fluid3D([4934,4962,4634,4383],0); -ELEMENTS[26698] = Fluid3D([5098,4962,5074,4744],0); -ELEMENTS[26699] = Fluid3D([4962,5074,4744,5168],0); -ELEMENTS[26700] = Fluid3D([4744,4962,5168,4672],0); -ELEMENTS[26701] = Fluid3D([5074,4744,5168,4782],0); -ELEMENTS[26702] = Fluid3D([5074,4744,4782,4431],0); -ELEMENTS[26703] = Fluid3D([4744,4782,4431,4516],0); -ELEMENTS[26704] = Fluid3D([5098,4962,4744,4634],0); -ELEMENTS[26705] = Fluid3D([4782,5074,4431,5249],0); -ELEMENTS[26706] = Fluid3D([4782,5074,5249,5168],0); -ELEMENTS[26707] = Fluid3D([4431,4782,5249,4606],0); -ELEMENTS[26708] = Fluid3D([4431,4782,4606,4516],0); -ELEMENTS[26709] = Fluid3D([5074,4744,4431,5131],0); -ELEMENTS[26710] = Fluid3D([5074,4744,5131,5098],0); -ELEMENTS[26711] = Fluid3D([5131,5074,5098,5515],0); -ELEMENTS[26712] = Fluid3D([5098,4934,4634,5395],0); -ELEMENTS[26713] = Fluid3D([4962,5515,5239,5377],0); -ELEMENTS[26714] = Fluid3D([4782,5249,4606,4978],0); -ELEMENTS[26715] = Fluid3D([5515,5074,5168,5249],0); -ELEMENTS[26716] = Fluid3D([4744,5168,4782,4516],0); -ELEMENTS[26717] = Fluid3D([4606,4782,4978,4516],0); -ELEMENTS[26718] = Fluid3D([5515,4934,5098,5395],0); -ELEMENTS[26719] = Fluid3D([4934,4962,4383,4427],0); -ELEMENTS[26720] = Fluid3D([5897,6667,5849,5986],0); -ELEMENTS[26721] = Fluid3D([5787,5897,5377,5713],0); -ELEMENTS[26722] = Fluid3D([5849,5787,5377,5585],0); -ELEMENTS[26723] = Fluid3D([12133,12982,12195,12793],0); -ELEMENTS[26724] = Fluid3D([12133,12982,12793,12976],0); -ELEMENTS[26725] = Fluid3D([12982,12195,12793,13158],0); -ELEMENTS[26726] = Fluid3D([12793,12982,13158,13470],0); -ELEMENTS[26727] = Fluid3D([12793,12982,13470,13279],0); -ELEMENTS[26728] = Fluid3D([13158,12793,13470,12805],0); -ELEMENTS[26729] = Fluid3D([14957,15531,15178,14824],0); -ELEMENTS[26730] = Fluid3D([4030,4242,3956,3777],0); -ELEMENTS[26731] = Fluid3D([10316,10304,10829,9187],0); -ELEMENTS[26732] = Fluid3D([5971,5796,6182,5565],0); -ELEMENTS[26733] = Fluid3D([6182,5971,5565,5752],0); -ELEMENTS[26734] = Fluid3D([5971,5796,5565,5447],0); -ELEMENTS[26735] = Fluid3D([5796,6182,5565,5754],0); -ELEMENTS[26736] = Fluid3D([7640,7817,8479,7820],0); -ELEMENTS[26737] = Fluid3D([14565,15336,14950,14761],0); -ELEMENTS[26738] = Fluid3D([15336,14950,14761,15119],0); -ELEMENTS[26739] = Fluid3D([14950,14761,15119,14337],0); -ELEMENTS[26740] = Fluid3D([15119,14950,14337,15097],0); -ELEMENTS[26741] = Fluid3D([14950,14565,14761,14119],0); -ELEMENTS[26742] = Fluid3D([14950,14565,14119,14278],0); -ELEMENTS[26743] = Fluid3D([14565,15336,14761,15007],0); -ELEMENTS[26744] = Fluid3D([14761,14950,14119,14337],0); -ELEMENTS[26745] = Fluid3D([14950,14119,14337,14278],0); -ELEMENTS[26746] = Fluid3D([14950,14565,14278,15082],0); -ELEMENTS[26747] = Fluid3D([14565,14119,14278,13768],0); -ELEMENTS[26748] = Fluid3D([14565,14761,14119,14298],0); -ELEMENTS[26749] = Fluid3D([13440,12671,13471,12718],0); -ELEMENTS[26750] = Fluid3D([16802,17225,16771,16779],0); -ELEMENTS[26751] = Fluid3D([16771,16802,16779,16335],0); -ELEMENTS[26752] = Fluid3D([17225,16771,16779,17095],0); -ELEMENTS[26753] = Fluid3D([16771,16779,17095,16672],0); -ELEMENTS[26754] = Fluid3D([17095,16771,16672,17164],0); -ELEMENTS[26755] = Fluid3D([16771,16779,16672,16284],0); -ELEMENTS[26756] = Fluid3D([16771,16779,16284,16335],0); -ELEMENTS[26757] = Fluid3D([17225,16771,17095,17164],0); -ELEMENTS[26758] = Fluid3D([13214,13240,13563,14092],0); -ELEMENTS[26759] = Fluid3D([16695,16290,16493,16745],0); -ELEMENTS[26760] = Fluid3D([3143,2978,2803,2948],0); -ELEMENTS[26761] = Fluid3D([12186,12897,12356,12279],0); -ELEMENTS[26762] = Fluid3D([14878,15267,15687,15572],0); -ELEMENTS[26763] = Fluid3D([15687,14878,15572,15839],0); -ELEMENTS[26764] = Fluid3D([4718,5264,5058,5477],0); -ELEMENTS[26765] = Fluid3D([10569,10366,11315,11014],0); -ELEMENTS[26766] = Fluid3D([10366,11315,11014,11293],0); -ELEMENTS[26767] = Fluid3D([10569,10366,11014,9990],0); -ELEMENTS[26768] = Fluid3D([10569,10366,9990,9649],0); -ELEMENTS[26769] = Fluid3D([11014,10569,9990,10425],0); -ELEMENTS[26770] = Fluid3D([10366,11014,9990,10346],0); -ELEMENTS[26771] = Fluid3D([11014,9990,10346,10546],0); -ELEMENTS[26772] = Fluid3D([10346,11014,10546,10767],0); -ELEMENTS[26773] = Fluid3D([9990,10366,10346,9368],0); -ELEMENTS[26774] = Fluid3D([9990,10346,10546,9702],0); -ELEMENTS[26775] = Fluid3D([11014,9990,10546,10425],0); -ELEMENTS[26776] = Fluid3D([11315,10569,11014,11246],0); -ELEMENTS[26777] = Fluid3D([11315,10569,11246,10498],0); -ELEMENTS[26778] = Fluid3D([10569,11246,10498,10599],0); -ELEMENTS[26779] = Fluid3D([11246,11315,10498,11331],0); -ELEMENTS[26780] = Fluid3D([10636,11499,11554,11038],0); -ELEMENTS[26781] = Fluid3D([18021,18165,18072,18290],0); -ELEMENTS[26782] = Fluid3D([10933,10327,9950,10930],0); -ELEMENTS[26783] = Fluid3D([10933,10327,10930,10956],0); -ELEMENTS[26784] = Fluid3D([9950,10933,10930,10824],0); -ELEMENTS[26785] = Fluid3D([10933,10930,10824,11791],0); -ELEMENTS[26786] = Fluid3D([10327,9950,10930,9570],0); -ELEMENTS[26787] = Fluid3D([14271,14676,14903,15418],0); -ELEMENTS[26788] = Fluid3D([5105,4601,5003,4975],0); -ELEMENTS[26789] = Fluid3D([3087,3133,2820,2910],0); -ELEMENTS[26790] = Fluid3D([16895,16432,16857,16756],0); -ELEMENTS[26791] = Fluid3D([9860,9963,10757,10679],0); -ELEMENTS[26792] = Fluid3D([16218,16333,16126,16715],0); -ELEMENTS[26793] = Fluid3D([9834,9616,8852,10114],0); -ELEMENTS[26794] = Fluid3D([15302,14806,14949,14965],0); -ELEMENTS[26795] = Fluid3D([16281,16245,16446,15862],0); -ELEMENTS[26796] = Fluid3D([16245,16446,15862,16149],0); -ELEMENTS[26797] = Fluid3D([16245,16446,16149,16696],0); -ELEMENTS[26798] = Fluid3D([16446,15862,16149,15668],0); -ELEMENTS[26799] = Fluid3D([15862,16245,16149,15728],0); -ELEMENTS[26800] = Fluid3D([16245,16149,15728,16325],0); -ELEMENTS[26801] = Fluid3D([16149,15862,15728,15470],0); -ELEMENTS[26802] = Fluid3D([15862,16245,15728,15548],0); -ELEMENTS[26803] = Fluid3D([16446,16281,15862,16195],0); -ELEMENTS[26804] = Fluid3D([16281,16245,15862,15548],0); -ELEMENTS[26805] = Fluid3D([2572,2372,2538,2384],0); -ELEMENTS[26806] = Fluid3D([2538,2572,2384,2680],0); -ELEMENTS[26807] = Fluid3D([2372,2538,2384,2261],0); -ELEMENTS[26808] = Fluid3D([2372,2538,2261,2465],0); -ELEMENTS[26809] = Fluid3D([2384,2372,2261,2135],0); -ELEMENTS[26810] = Fluid3D([2372,2261,2135,2234],0); -ELEMENTS[26811] = Fluid3D([2572,2372,2384,2337],0); -ELEMENTS[26812] = Fluid3D([2538,2384,2261,2550],0); -ELEMENTS[26813] = Fluid3D([2261,2384,2135,2126],0); -ELEMENTS[26814] = Fluid3D([2135,2261,2126,2034],0); -ELEMENTS[26815] = Fluid3D([2261,2384,2126,2310],0); -ELEMENTS[26816] = Fluid3D([2126,2261,2310,2193],0); -ELEMENTS[26817] = Fluid3D([2126,2135,2034,1959],0); -ELEMENTS[26818] = Fluid3D([2135,2034,1959,1972],0); -ELEMENTS[26819] = Fluid3D([2135,2034,1972,2234],0); -ELEMENTS[26820] = Fluid3D([2126,2135,1959,2109],0); -ELEMENTS[26821] = Fluid3D([2135,1959,2109,1966],0); -ELEMENTS[26822] = Fluid3D([1959,2126,2109,1995],0); -ELEMENTS[26823] = Fluid3D([2126,2135,2109,2384],0); -ELEMENTS[26824] = Fluid3D([2261,2384,2310,2550],0); -ELEMENTS[26825] = Fluid3D([2034,1959,1972,1854],0); -ELEMENTS[26826] = Fluid3D([2034,1959,1854,1876],0); -ELEMENTS[26827] = Fluid3D([1959,1854,1876,1756],0); -ELEMENTS[26828] = Fluid3D([1959,1972,1854,1756],0); -ELEMENTS[26829] = Fluid3D([1972,2034,1854,1948],0); -ELEMENTS[26830] = Fluid3D([1972,2034,1948,2234],0); -ELEMENTS[26831] = Fluid3D([2034,1854,1948,2026],0); -ELEMENTS[26832] = Fluid3D([1948,2034,2026,2167],0); -ELEMENTS[26833] = Fluid3D([1854,1972,1948,1828],0); -ELEMENTS[26834] = Fluid3D([1972,1948,1828,1955],0); -ELEMENTS[26835] = Fluid3D([1854,1972,1828,1756],0); -ELEMENTS[26836] = Fluid3D([1948,1828,1955,1846],0); -ELEMENTS[26837] = Fluid3D([1955,1948,1846,2057],0); -ELEMENTS[26838] = Fluid3D([1948,1828,1846,1783],0); -ELEMENTS[26839] = Fluid3D([1948,1828,1783,1854],0); -ELEMENTS[26840] = Fluid3D([1828,1846,1783,1681],0); -ELEMENTS[26841] = Fluid3D([1828,1955,1846,1812],0); -ELEMENTS[26842] = Fluid3D([1955,1846,1812,1933],0); -ELEMENTS[26843] = Fluid3D([1955,1846,1933,1906],0); -ELEMENTS[26844] = Fluid3D([1846,1933,1906,1782],0); -ELEMENTS[26845] = Fluid3D([1906,1846,1782,1814],0); -ELEMENTS[26846] = Fluid3D([1906,1846,1814,1868],0); -ELEMENTS[26847] = Fluid3D([1906,1846,1868,2057],0); -ELEMENTS[26848] = Fluid3D([1846,1933,1782,1812],0); -ELEMENTS[26849] = Fluid3D([1782,1846,1812,1681],0); -ELEMENTS[26850] = Fluid3D([1933,1782,1812,1874],0); -ELEMENTS[26851] = Fluid3D([1933,1782,1874,1907],0); -ELEMENTS[26852] = Fluid3D([1874,1933,1907,2025],0); -ELEMENTS[26853] = Fluid3D([1782,1906,1814,1907],0); -ELEMENTS[26854] = Fluid3D([1906,1814,1907,2046],0); -ELEMENTS[26855] = Fluid3D([1933,1906,1782,1907],0); -ELEMENTS[26856] = Fluid3D([1933,1906,1907,2046],0); -ELEMENTS[26857] = Fluid3D([1906,1846,2057,1955],0); -ELEMENTS[26858] = Fluid3D([1828,1955,1812,1888],0); -ELEMENTS[26859] = Fluid3D([1972,1948,1955,2234],0); -ELEMENTS[26860] = Fluid3D([1828,1972,1955,1888],0); -ELEMENTS[26861] = Fluid3D([1846,1828,1812,1681],0); -ELEMENTS[26862] = Fluid3D([1812,1955,1933,2018],0); -ELEMENTS[26863] = Fluid3D([2261,2126,2034,2193],0); -ELEMENTS[26864] = Fluid3D([1846,1948,1783,1868],0); -ELEMENTS[26865] = Fluid3D([1783,1846,1868,1706],0); -ELEMENTS[26866] = Fluid3D([1948,1783,1868,1881],0); -ELEMENTS[26867] = Fluid3D([1783,1868,1881,1705],0); -ELEMENTS[26868] = Fluid3D([1948,1783,1881,1854],0); -ELEMENTS[26869] = Fluid3D([1868,1948,1881,2026],0); -ELEMENTS[26870] = Fluid3D([1948,1881,2026,1854],0); -ELEMENTS[26871] = Fluid3D([1881,1868,2026,2019],0); -ELEMENTS[26872] = Fluid3D([1868,1948,2026,2057],0); -ELEMENTS[26873] = Fluid3D([1948,2026,2057,2167],0); -ELEMENTS[26874] = Fluid3D([2034,2126,1959,1876],0); -ELEMENTS[26875] = Fluid3D([2384,2372,2135,2337],0); -ELEMENTS[26876] = Fluid3D([2135,2261,2034,2234],0); -ELEMENTS[26877] = Fluid3D([1959,2135,1972,1966],0); -ELEMENTS[26878] = Fluid3D([2384,2126,2310,2263],0); -ELEMENTS[26879] = Fluid3D([2126,2310,2263,2028],0); -ELEMENTS[26880] = Fluid3D([2384,2126,2263,2109],0); -ELEMENTS[26881] = Fluid3D([2310,2384,2263,2425],0); -ELEMENTS[26882] = Fluid3D([2263,2310,2425,2207],0); -ELEMENTS[26883] = Fluid3D([17236,17244,17433,17432],0); -ELEMENTS[26884] = Fluid3D([4362,4690,4391,4879],0); -ELEMENTS[26885] = Fluid3D([13694,13813,13010,13182],0); -ELEMENTS[26886] = Fluid3D([13813,13010,13182,13091],0); -ELEMENTS[26887] = Fluid3D([9712,9392,10398,10487],0); -ELEMENTS[26888] = Fluid3D([10398,9712,10487,10560],0); -ELEMENTS[26889] = Fluid3D([5381,5658,5186,5183],0); -ELEMENTS[26890] = Fluid3D([18277,18392,18459,18460],0); -ELEMENTS[26891] = Fluid3D([11003,11394,10390,10477],0); -ELEMENTS[26892] = Fluid3D([9568,9761,9014,9135],0); -ELEMENTS[26893] = Fluid3D([4121,4595,4250,4619],0); -ELEMENTS[26894] = Fluid3D([4595,4250,4619,4998],0); -ELEMENTS[26895] = Fluid3D([4121,4595,4619,4650],0); -ELEMENTS[26896] = Fluid3D([4121,4595,4650,4314],0); -ELEMENTS[26897] = Fluid3D([4619,4121,4650,4237],0); -ELEMENTS[26898] = Fluid3D([4595,4619,4650,5118],0); -ELEMENTS[26899] = Fluid3D([4650,4595,5118,4850],0); -ELEMENTS[26900] = Fluid3D([4619,4650,5118,5018],0); -ELEMENTS[26901] = Fluid3D([4650,5118,5018,5524],0); -ELEMENTS[26902] = Fluid3D([4595,4619,5118,4998],0); -ELEMENTS[26903] = Fluid3D([4619,4650,5018,4723],0); -ELEMENTS[26904] = Fluid3D([4650,5018,4723,5524],0); -ELEMENTS[26905] = Fluid3D([5118,4619,5018,5476],0); -ELEMENTS[26906] = Fluid3D([4250,4121,4619,3905],0); -ELEMENTS[26907] = Fluid3D([11096,11932,11498,10671],0); -ELEMENTS[26908] = Fluid3D([15263,14917,15297,15565],0); -ELEMENTS[26909] = Fluid3D([4997,4587,4384,4778],0); -ELEMENTS[26910] = Fluid3D([4997,4587,4778,5099],0); -ELEMENTS[26911] = Fluid3D([4384,4997,4778,4817],0); -ELEMENTS[26912] = Fluid3D([4587,4384,4778,4259],0); -ELEMENTS[26913] = Fluid3D([4778,4587,4259,4425],0); -ELEMENTS[26914] = Fluid3D([4587,4384,4259,4171],0); -ELEMENTS[26915] = Fluid3D([4303,3812,3984,4126],0); -ELEMENTS[26916] = Fluid3D([12103,12637,12870,13155],0); -ELEMENTS[26917] = Fluid3D([9908,10184,11016,10352],0); -ELEMENTS[26918] = Fluid3D([11016,9908,10352,11230],0); -ELEMENTS[26919] = Fluid3D([10352,11016,11230,11183],0); -ELEMENTS[26920] = Fluid3D([13721,13376,13693,12824],0); -ELEMENTS[26921] = Fluid3D([16322,15616,15900,15841],0); -ELEMENTS[26922] = Fluid3D([3591,3503,3210,3563],0); -ELEMENTS[26923] = Fluid3D([3210,3591,3563,3277],0); -ELEMENTS[26924] = Fluid3D([3591,3503,3563,4067],0); -ELEMENTS[26925] = Fluid3D([3503,3210,3563,3226],0); -ELEMENTS[26926] = Fluid3D([14156,13545,13272,13103],0); -ELEMENTS[26927] = Fluid3D([13545,13272,13103,12801],0); -ELEMENTS[26928] = Fluid3D([13103,13545,12801,12681],0); -ELEMENTS[26929] = Fluid3D([13545,13272,12801,13816],0); -ELEMENTS[26930] = Fluid3D([13102,12619,12845,12403],0); -ELEMENTS[26931] = Fluid3D([6531,6018,5838,5927],0); -ELEMENTS[26932] = Fluid3D([7124,6589,7451,6956],0); -ELEMENTS[26933] = Fluid3D([7451,7124,6956,7940],0); -ELEMENTS[26934] = Fluid3D([7124,6956,7940,7134],0); -ELEMENTS[26935] = Fluid3D([7124,6956,7134,6321],0); -ELEMENTS[26936] = Fluid3D([6956,7940,7134,7475],0); -ELEMENTS[26937] = Fluid3D([7134,6956,7475,6442],0); -ELEMENTS[26938] = Fluid3D([6956,7940,7475,7501],0); -ELEMENTS[26939] = Fluid3D([7475,6956,7501,6543],0); -ELEMENTS[26940] = Fluid3D([6956,7501,6543,6892],0); -ELEMENTS[26941] = Fluid3D([7475,6956,6543,6442],0); -ELEMENTS[26942] = Fluid3D([6956,7940,7501,7451],0); -ELEMENTS[26943] = Fluid3D([7501,6956,7451,6892],0); -ELEMENTS[26944] = Fluid3D([7124,6589,6956,6321],0); -ELEMENTS[26945] = Fluid3D([7940,7134,7475,7979],0); -ELEMENTS[26946] = Fluid3D([7134,7475,7979,7285],0); -ELEMENTS[26947] = Fluid3D([7940,7134,7979,7794],0); -ELEMENTS[26948] = Fluid3D([7979,7134,7285,7497],0); -ELEMENTS[26949] = Fluid3D([7979,7134,7497,7794],0); -ELEMENTS[26950] = Fluid3D([7285,7979,7497,8097],0); -ELEMENTS[26951] = Fluid3D([7940,7134,7794,7124],0); -ELEMENTS[26952] = Fluid3D([7475,7940,7979,8350],0); -ELEMENTS[26953] = Fluid3D([7940,7979,8350,8884],0); -ELEMENTS[26954] = Fluid3D([7475,7940,8350,7501],0); -ELEMENTS[26955] = Fluid3D([7979,7940,7794,8884],0); -ELEMENTS[26956] = Fluid3D([7134,7475,7285,6442],0); -ELEMENTS[26957] = Fluid3D([7979,7475,8350,8333],0); -ELEMENTS[26958] = Fluid3D([6589,7451,6956,6892],0); -ELEMENTS[26959] = Fluid3D([7134,7285,7497,6437],0); -ELEMENTS[26960] = Fluid3D([7475,7979,7285,8333],0); -ELEMENTS[26961] = Fluid3D([7451,7124,7940,7880],0); -ELEMENTS[26962] = Fluid3D([7451,7124,7880,7148],0); -ELEMENTS[26963] = Fluid3D([7124,7940,7880,7794],0); -ELEMENTS[26964] = Fluid3D([7940,7451,7880,8344],0); -ELEMENTS[26965] = Fluid3D([6563,7363,6572,7078],0); -ELEMENTS[26966] = Fluid3D([9790,9068,9956,9488],0); -ELEMENTS[26967] = Fluid3D([18602,18524,18561,18600],0); -ELEMENTS[26968] = Fluid3D([15343,15676,15851,15956],0); -ELEMENTS[26969] = Fluid3D([15851,15343,15956,15771],0); -ELEMENTS[26970] = Fluid3D([15343,15956,15771,15632],0); -ELEMENTS[26971] = Fluid3D([15343,15676,15956,15396],0); -ELEMENTS[26972] = Fluid3D([15956,15771,15632,16218],0); -ELEMENTS[26973] = Fluid3D([15632,15956,16218,15396],0); -ELEMENTS[26974] = Fluid3D([15851,15343,15771,15034],0); -ELEMENTS[26975] = Fluid3D([15956,15851,15771,16332],0); -ELEMENTS[26976] = Fluid3D([15956,15851,16332,16469],0); -ELEMENTS[26977] = Fluid3D([16332,15956,16469,16218],0); -ELEMENTS[26978] = Fluid3D([15956,16469,16218,16126],0); -ELEMENTS[26979] = Fluid3D([15851,15771,16332,15742],0); -ELEMENTS[26980] = Fluid3D([15851,15771,15742,15034],0); -ELEMENTS[26981] = Fluid3D([15771,15956,16332,16218],0); -ELEMENTS[26982] = Fluid3D([15676,15851,15956,16469],0); -ELEMENTS[26983] = Fluid3D([15771,16332,15742,16463],0); -ELEMENTS[26984] = Fluid3D([10306,10689,10770,10144],0); -ELEMENTS[26985] = Fluid3D([4337,4679,4531,4343],0); -ELEMENTS[26986] = Fluid3D([17868,17608,17946,17863],0); -ELEMENTS[26987] = Fluid3D([9335,8950,9357,10079],0); -ELEMENTS[26988] = Fluid3D([9357,9335,10079,10241],0); -ELEMENTS[26989] = Fluid3D([14614,14420,14944,13954],0); -ELEMENTS[26990] = Fluid3D([5798,5348,5978,5893],0); -ELEMENTS[26991] = Fluid3D([5798,5348,5893,5602],0); -ELEMENTS[26992] = Fluid3D([5893,5798,5602,6251],0); -ELEMENTS[26993] = Fluid3D([4798,4338,4564,4331],0); -ELEMENTS[26994] = Fluid3D([4798,4338,4331,4272],0); -ELEMENTS[26995] = Fluid3D([4338,4564,4331,4087],0); -ELEMENTS[26996] = Fluid3D([4338,4564,4087,4526],0); -ELEMENTS[26997] = Fluid3D([4331,4338,4087,3897],0); -ELEMENTS[26998] = Fluid3D([4331,4338,3897,4272],0); -ELEMENTS[26999] = Fluid3D([4338,4087,3897,3958],0); -ELEMENTS[27000] = Fluid3D([4564,4331,4087,4372],0); -ELEMENTS[27001] = Fluid3D([4087,4564,4372,4350],0); -ELEMENTS[27002] = Fluid3D([4372,4087,4350,3669],0); -ELEMENTS[27003] = Fluid3D([4564,4331,4372,4814],0); -ELEMENTS[27004] = Fluid3D([4564,4331,4814,4798],0); -ELEMENTS[27005] = Fluid3D([4331,4087,4372,3906],0); -ELEMENTS[27006] = Fluid3D([4087,4372,3906,3669],0); -ELEMENTS[27007] = Fluid3D([4331,4087,3906,3897],0); -ELEMENTS[27008] = Fluid3D([4331,4372,4814,4335],0); -ELEMENTS[27009] = Fluid3D([4814,4331,4335,4834],0); -ELEMENTS[27010] = Fluid3D([4372,4564,4814,4965],0); -ELEMENTS[27011] = Fluid3D([4372,4331,3906,4335],0); -ELEMENTS[27012] = Fluid3D([4564,4372,4350,4965],0); -ELEMENTS[27013] = Fluid3D([8217,9177,8820,8945],0); -ELEMENTS[27014] = Fluid3D([15479,16097,16132,15916],0); -ELEMENTS[27015] = Fluid3D([15479,16097,15916,15284],0); -ELEMENTS[27016] = Fluid3D([16132,15479,15916,15756],0); -ELEMENTS[27017] = Fluid3D([16132,15479,15756,16014],0); -ELEMENTS[27018] = Fluid3D([15756,16132,16014,16200],0); -ELEMENTS[27019] = Fluid3D([15756,16132,16200,15916],0); -ELEMENTS[27020] = Fluid3D([16200,15756,15916,15921],0); -ELEMENTS[27021] = Fluid3D([15916,16200,15921,16362],0); -ELEMENTS[27022] = Fluid3D([16200,15756,15921,15731],0); -ELEMENTS[27023] = Fluid3D([16200,15756,15731,16014],0); -ELEMENTS[27024] = Fluid3D([15756,15916,15921,15003],0); -ELEMENTS[27025] = Fluid3D([15756,15731,16014,15371],0); -ELEMENTS[27026] = Fluid3D([15756,15731,15371,15112],0); -ELEMENTS[27027] = Fluid3D([16014,15756,15371,15479],0); -ELEMENTS[27028] = Fluid3D([15756,15371,15479,15003],0); -ELEMENTS[27029] = Fluid3D([16132,16200,15916,16381],0); -ELEMENTS[27030] = Fluid3D([16200,15916,16381,16362],0); -ELEMENTS[27031] = Fluid3D([15756,15731,15112,15921],0); -ELEMENTS[27032] = Fluid3D([15371,15756,15112,15003],0); -ELEMENTS[27033] = Fluid3D([15916,16132,16381,16097],0); -ELEMENTS[27034] = Fluid3D([15479,15916,15756,15003],0); -ELEMENTS[27035] = Fluid3D([12678,12535,12323,13445],0); -ELEMENTS[27036] = Fluid3D([11297,11332,10834,11713],0); -ELEMENTS[27037] = Fluid3D([14685,15240,15144,14599],0); -ELEMENTS[27038] = Fluid3D([6072,5750,5757,6645],0); -ELEMENTS[27039] = Fluid3D([10397,10520,11044,11379],0); -ELEMENTS[27040] = Fluid3D([10239,10623,10318,9429],0); -ELEMENTS[27041] = Fluid3D([15828,15947,16373,16116],0); -ELEMENTS[27042] = Fluid3D([15828,15947,16116,15344],0); -ELEMENTS[27043] = Fluid3D([15947,16373,16116,16421],0); -ELEMENTS[27044] = Fluid3D([15947,16373,16421,16366],0); -ELEMENTS[27045] = Fluid3D([15947,16373,16366,15911],0); -ELEMENTS[27046] = Fluid3D([16421,15947,16366,16110],0); -ELEMENTS[27047] = Fluid3D([16421,15947,16110,16179],0); -ELEMENTS[27048] = Fluid3D([16110,16421,16179,16571],0); -ELEMENTS[27049] = Fluid3D([16179,16110,16571,16765],0); -ELEMENTS[27050] = Fluid3D([16421,16179,16571,16722],0); -ELEMENTS[27051] = Fluid3D([16421,16179,16722,16276],0); -ELEMENTS[27052] = Fluid3D([16571,16421,16722,16912],0); -ELEMENTS[27053] = Fluid3D([16421,16722,16912,16773],0); -ELEMENTS[27054] = Fluid3D([16421,16722,16773,16276],0); -ELEMENTS[27055] = Fluid3D([16722,16912,16773,17090],0); -ELEMENTS[27056] = Fluid3D([16912,16421,16773,16373],0); -ELEMENTS[27057] = Fluid3D([16773,16722,17090,16832],0); -ELEMENTS[27058] = Fluid3D([16773,16722,16832,16276],0); -ELEMENTS[27059] = Fluid3D([16722,16912,17090,17403],0); -ELEMENTS[27060] = Fluid3D([16110,16421,16571,16366],0); -ELEMENTS[27061] = Fluid3D([16722,16571,16912,16765],0); -ELEMENTS[27062] = Fluid3D([17090,16773,16832,17143],0); -ELEMENTS[27063] = Fluid3D([16773,16832,17143,16554],0); -ELEMENTS[27064] = Fluid3D([16773,16832,16554,16276],0); -ELEMENTS[27065] = Fluid3D([16571,16421,16912,16366],0); -ELEMENTS[27066] = Fluid3D([17090,16773,17143,17366],0); -ELEMENTS[27067] = Fluid3D([16912,16773,17090,17366],0); -ELEMENTS[27068] = Fluid3D([15947,16366,16110,15907],0); -ELEMENTS[27069] = Fluid3D([16116,15947,16421,15636],0); -ELEMENTS[27070] = Fluid3D([16110,15947,15907,15531],0); -ELEMENTS[27071] = Fluid3D([15907,16110,15531,16063],0); -ELEMENTS[27072] = Fluid3D([15531,15907,16063,15522],0); -ELEMENTS[27073] = Fluid3D([16063,15531,15522,15562],0); -ELEMENTS[27074] = Fluid3D([15907,16110,16063,16366],0); -ELEMENTS[27075] = Fluid3D([16179,16571,16722,16765],0); -ELEMENTS[27076] = Fluid3D([15947,16366,15907,15911],0); -ELEMENTS[27077] = Fluid3D([16373,15828,16116,16324],0); -ELEMENTS[27078] = Fluid3D([16373,16421,16366,16912],0); -ELEMENTS[27079] = Fluid3D([16373,16116,16421,16773],0); -ELEMENTS[27080] = Fluid3D([15234,15867,15765,15419],0); -ELEMENTS[27081] = Fluid3D([13869,14709,14139,14273],0); -ELEMENTS[27082] = Fluid3D([14474,14553,14427,15028],0); -ELEMENTS[27083] = Fluid3D([2954,2865,2666,2987],0); -ELEMENTS[27084] = Fluid3D([3122,3252,3546,3313],0); -ELEMENTS[27085] = Fluid3D([16430,16660,16627,17016],0); -ELEMENTS[27086] = Fluid3D([5264,5783,5477,5178],0); -ELEMENTS[27087] = Fluid3D([8722,7604,8270,7893],0); -ELEMENTS[27088] = Fluid3D([11943,12359,12644,12755],0); -ELEMENTS[27089] = Fluid3D([11801,11898,10990,11862],0); -ELEMENTS[27090] = Fluid3D([10990,11801,11862,11239],0); -ELEMENTS[27091] = Fluid3D([11801,11898,11862,13099],0); -ELEMENTS[27092] = Fluid3D([11801,11862,11239,12232],0); -ELEMENTS[27093] = Fluid3D([11801,11862,12232,13099],0); -ELEMENTS[27094] = Fluid3D([11239,11801,12232,11657],0); -ELEMENTS[27095] = Fluid3D([11239,11801,11657,10859],0); -ELEMENTS[27096] = Fluid3D([11657,11239,10859,10965],0); -ELEMENTS[27097] = Fluid3D([10859,11657,10965,11009],0); -ELEMENTS[27098] = Fluid3D([11239,10859,10965,10209],0); -ELEMENTS[27099] = Fluid3D([10859,10965,10209,10042],0); -ELEMENTS[27100] = Fluid3D([11657,11239,10965,11921],0); -ELEMENTS[27101] = Fluid3D([10965,11239,10209,10605],0); -ELEMENTS[27102] = Fluid3D([10209,10965,10605,10023],0); -ELEMENTS[27103] = Fluid3D([10209,10965,10023,10042],0); -ELEMENTS[27104] = Fluid3D([10605,10209,10023,9610],0); -ELEMENTS[27105] = Fluid3D([11239,10859,10209,10990],0); -ELEMENTS[27106] = Fluid3D([11801,12232,11657,12575],0); -ELEMENTS[27107] = Fluid3D([11862,11239,12232,11771],0); -ELEMENTS[27108] = Fluid3D([12232,11862,11771,12912],0); -ELEMENTS[27109] = Fluid3D([11239,12232,11771,11921],0); -ELEMENTS[27110] = Fluid3D([11862,11239,11771,11235],0); -ELEMENTS[27111] = Fluid3D([11771,11862,11235,12451],0); -ELEMENTS[27112] = Fluid3D([11862,11239,11235,10990],0); -ELEMENTS[27113] = Fluid3D([11239,11771,11235,10605],0); -ELEMENTS[27114] = Fluid3D([11771,11862,12451,12912],0); -ELEMENTS[27115] = Fluid3D([10990,11801,11239,10859],0); -ELEMENTS[27116] = Fluid3D([11898,10990,11862,11418],0); -ELEMENTS[27117] = Fluid3D([12232,11239,11657,11921],0); -ELEMENTS[27118] = Fluid3D([17247,17529,17207,17491],0); -ELEMENTS[27119] = Fluid3D([13325,12524,12562,12990],0); -ELEMENTS[27120] = Fluid3D([12524,12562,12990,11950],0); -ELEMENTS[27121] = Fluid3D([13325,12524,12990,13489],0); -ELEMENTS[27122] = Fluid3D([12562,13325,12990,13632],0); -ELEMENTS[27123] = Fluid3D([13325,12990,13632,13472],0); -ELEMENTS[27124] = Fluid3D([12990,13632,13472,13673],0); -ELEMENTS[27125] = Fluid3D([13325,12990,13472,13489],0); -ELEMENTS[27126] = Fluid3D([12990,13472,13489,12675],0); -ELEMENTS[27127] = Fluid3D([12990,13472,12675,12569],0); -ELEMENTS[27128] = Fluid3D([12990,13472,12569,13673],0); -ELEMENTS[27129] = Fluid3D([12675,12990,12569,11950],0); -ELEMENTS[27130] = Fluid3D([12990,12569,11950,12562],0); -ELEMENTS[27131] = Fluid3D([7320,8120,7628,7726],0); -ELEMENTS[27132] = Fluid3D([10361,10084,10699,9688],0); -ELEMENTS[27133] = Fluid3D([10361,10084,9688,9374],0); -ELEMENTS[27134] = Fluid3D([10699,10361,9688,9809],0); -ELEMENTS[27135] = Fluid3D([10084,10699,9688,9961],0); -ELEMENTS[27136] = Fluid3D([9688,10084,9961,9174],0); -ELEMENTS[27137] = Fluid3D([10084,9961,9174,9944],0); -ELEMENTS[27138] = Fluid3D([10084,10699,9961,10874],0); -ELEMENTS[27139] = Fluid3D([9961,9688,9174,9109],0); -ELEMENTS[27140] = Fluid3D([9174,9961,9109,9126],0); -ELEMENTS[27141] = Fluid3D([9109,9174,9126,8380],0); -ELEMENTS[27142] = Fluid3D([9109,9174,8380,8353],0); -ELEMENTS[27143] = Fluid3D([9174,9126,8380,8815],0); -ELEMENTS[27144] = Fluid3D([8380,9174,8815,8353],0); -ELEMENTS[27145] = Fluid3D([9688,10084,9174,9374],0); -ELEMENTS[27146] = Fluid3D([10699,9688,9961,9850],0); -ELEMENTS[27147] = Fluid3D([3719,4086,3677,3617],0); -ELEMENTS[27148] = Fluid3D([16132,16097,16498,16381],0); -ELEMENTS[27149] = Fluid3D([5765,6140,5626,5897],0); -ELEMENTS[27150] = Fluid3D([7272,7432,6856,6261],0); -ELEMENTS[27151] = Fluid3D([7171,7868,7133,7608],0); -ELEMENTS[27152] = Fluid3D([8607,8878,9117,8289],0); -ELEMENTS[27153] = Fluid3D([6644,6146,5922,5863],0); -ELEMENTS[27154] = Fluid3D([6146,5922,5863,5299],0); -ELEMENTS[27155] = Fluid3D([5922,6644,5863,6682],0); -ELEMENTS[27156] = Fluid3D([13144,12209,12719,12327],0); -ELEMENTS[27157] = Fluid3D([15182,15658,14854,15587],0); -ELEMENTS[27158] = Fluid3D([11456,10781,10708,10290],0); -ELEMENTS[27159] = Fluid3D([8841,9583,9506,8584],0); -ELEMENTS[27160] = Fluid3D([6169,5805,6253,6575],0); -ELEMENTS[27161] = Fluid3D([2234,2475,2406,2381],0); -ELEMENTS[27162] = Fluid3D([16069,16102,15815,16514],0); -ELEMENTS[27163] = Fluid3D([9779,10698,10635,10275],0); -ELEMENTS[27164] = Fluid3D([9779,10698,10275,9985],0); -ELEMENTS[27165] = Fluid3D([10698,10275,9985,10476],0); -ELEMENTS[27166] = Fluid3D([10635,9779,10275,9461],0); -ELEMENTS[27167] = Fluid3D([10275,9985,10476,10130],0); -ELEMENTS[27168] = Fluid3D([10476,10275,10130,11028],0); -ELEMENTS[27169] = Fluid3D([10275,10130,11028,11168],0); -ELEMENTS[27170] = Fluid3D([10476,10275,11028,10698],0); -ELEMENTS[27171] = Fluid3D([10130,10476,11028,10928],0); -ELEMENTS[27172] = Fluid3D([10476,11028,10928,11637],0); -ELEMENTS[27173] = Fluid3D([10928,10476,11637,11042],0); -ELEMENTS[27174] = Fluid3D([10476,11028,11637,11042],0); -ELEMENTS[27175] = Fluid3D([10928,10476,11042,9985],0); -ELEMENTS[27176] = Fluid3D([10275,9985,10130,9461],0); -ELEMENTS[27177] = Fluid3D([10130,10275,9461,10357],0); -ELEMENTS[27178] = Fluid3D([9779,10698,9985,9982],0); -ELEMENTS[27179] = Fluid3D([9985,10698,10476,11042],0); -ELEMENTS[27180] = Fluid3D([10698,10476,11042,11028],0); -ELEMENTS[27181] = Fluid3D([10275,9779,9985,9461],0); -ELEMENTS[27182] = Fluid3D([10698,10635,10275,11445],0); -ELEMENTS[27183] = Fluid3D([9474,8660,8648,8997],0); -ELEMENTS[27184] = Fluid3D([9689,9169,8927,9822],0); -ELEMENTS[27185] = Fluid3D([15838,15410,16029,15881],0); -ELEMENTS[27186] = Fluid3D([16436,16247,16723,16614],0); -ELEMENTS[27187] = Fluid3D([15968,16170,16384,15778],0); -ELEMENTS[27188] = Fluid3D([3124,3246,3299,2984],0); -ELEMENTS[27189] = Fluid3D([3124,3246,2984,2714],0); -ELEMENTS[27190] = Fluid3D([3299,3124,2984,2964],0); -ELEMENTS[27191] = Fluid3D([3246,3299,2984,3117],0); -ELEMENTS[27192] = Fluid3D([2984,3246,3117,2714],0); -ELEMENTS[27193] = Fluid3D([3299,3124,2964,3369],0); -ELEMENTS[27194] = Fluid3D([2984,3299,2964,2976],0); -ELEMENTS[27195] = Fluid3D([2984,3299,2976,3117],0); -ELEMENTS[27196] = Fluid3D([2964,2984,2976,2652],0); -ELEMENTS[27197] = Fluid3D([2984,2976,2652,2733],0); -ELEMENTS[27198] = Fluid3D([2964,2984,2652,3124],0); -ELEMENTS[27199] = Fluid3D([3299,2964,2976,3357],0); -ELEMENTS[27200] = Fluid3D([2976,3299,3357,3212],0); -ELEMENTS[27201] = Fluid3D([3357,2976,3212,3114],0); -ELEMENTS[27202] = Fluid3D([3299,3357,3212,3542],0); -ELEMENTS[27203] = Fluid3D([3212,3299,3542,3117],0); -ELEMENTS[27204] = Fluid3D([2964,2976,3357,3064],0); -ELEMENTS[27205] = Fluid3D([2976,3357,3064,3114],0); -ELEMENTS[27206] = Fluid3D([2976,3299,3212,3117],0); -ELEMENTS[27207] = Fluid3D([4267,4350,4361,3945],0); -ELEMENTS[27208] = Fluid3D([4267,4350,3945,4572],0); -ELEMENTS[27209] = Fluid3D([4361,4267,3945,3856],0); -ELEMENTS[27210] = Fluid3D([4267,3945,3856,3612],0); -ELEMENTS[27211] = Fluid3D([12792,12510,12610,13428],0); -ELEMENTS[27212] = Fluid3D([7929,7907,7550,6890],0); -ELEMENTS[27213] = Fluid3D([14967,15473,14939,15247],0); -ELEMENTS[27214] = Fluid3D([14939,14967,15247,14487],0); -ELEMENTS[27215] = Fluid3D([14967,15247,14487,15124],0); -ELEMENTS[27216] = Fluid3D([14967,15247,15124,15652],0); -ELEMENTS[27217] = Fluid3D([14967,15247,15652,15473],0); -ELEMENTS[27218] = Fluid3D([15124,14967,15652,15216],0); -ELEMENTS[27219] = Fluid3D([14939,14967,14487,14184],0); -ELEMENTS[27220] = Fluid3D([3285,3173,3041,2859],0); -ELEMENTS[27221] = Fluid3D([3173,3041,2859,3163],0); -ELEMENTS[27222] = Fluid3D([15790,15258,15231,15193],0); -ELEMENTS[27223] = Fluid3D([15231,15790,15193,15588],0); -ELEMENTS[27224] = Fluid3D([15790,15193,15588,15770],0); -ELEMENTS[27225] = Fluid3D([15193,15588,15770,15248],0); -ELEMENTS[27226] = Fluid3D([15588,15770,15248,15868],0); -ELEMENTS[27227] = Fluid3D([15588,15770,15868,16186],0); -ELEMENTS[27228] = Fluid3D([15588,15770,16186,15790],0); -ELEMENTS[27229] = Fluid3D([15770,15868,16186,16283],0); -ELEMENTS[27230] = Fluid3D([15868,16186,16283,16440],0); -ELEMENTS[27231] = Fluid3D([15770,15868,16283,15791],0); -ELEMENTS[27232] = Fluid3D([15868,16283,15791,16173],0); -ELEMENTS[27233] = Fluid3D([15868,16186,16440,16070],0); -ELEMENTS[27234] = Fluid3D([15868,16186,16070,15588],0); -ELEMENTS[27235] = Fluid3D([15790,15258,15193,15502],0); -ELEMENTS[27236] = Fluid3D([15868,16283,16173,16440],0); -ELEMENTS[27237] = Fluid3D([15770,15868,15791,15248],0); -ELEMENTS[27238] = Fluid3D([16186,16440,16070,16628],0); -ELEMENTS[27239] = Fluid3D([15790,15193,15770,15502],0); -ELEMENTS[27240] = Fluid3D([16283,15791,16173,16434],0); -ELEMENTS[27241] = Fluid3D([16186,16283,16440,16703],0); -ELEMENTS[27242] = Fluid3D([16186,16283,16703,16358],0); -ELEMENTS[27243] = Fluid3D([16283,16440,16703,16738],0); -ELEMENTS[27244] = Fluid3D([16703,16283,16738,16718],0); -ELEMENTS[27245] = Fluid3D([16703,16283,16718,16358],0); -ELEMENTS[27246] = Fluid3D([16703,16186,16358,16681],0); -ELEMENTS[27247] = Fluid3D([16283,16440,16738,16173],0); -ELEMENTS[27248] = Fluid3D([16440,16186,16703,16953],0); -ELEMENTS[27249] = Fluid3D([16283,16738,16718,16434],0); -ELEMENTS[27250] = Fluid3D([16186,16283,16358,15770],0); -ELEMENTS[27251] = Fluid3D([16440,16703,16738,16953],0); -ELEMENTS[27252] = Fluid3D([15193,15588,15248,15076],0); -ELEMENTS[27253] = Fluid3D([15588,15248,15076,15868],0); -ELEMENTS[27254] = Fluid3D([15770,15193,15248,15386],0); -ELEMENTS[27255] = Fluid3D([16283,15770,15791,16023],0); -ELEMENTS[27256] = Fluid3D([16283,15770,16023,16358],0); -ELEMENTS[27257] = Fluid3D([15791,16283,16023,16351],0); -ELEMENTS[27258] = Fluid3D([16023,15791,16351,15872],0); -ELEMENTS[27259] = Fluid3D([15791,16351,15872,16434],0); -ELEMENTS[27260] = Fluid3D([15791,16283,16351,16434],0); -ELEMENTS[27261] = Fluid3D([15770,15791,16023,15677],0); -ELEMENTS[27262] = Fluid3D([16283,16023,16351,16718],0); -ELEMENTS[27263] = Fluid3D([16351,15872,16434,16246],0); -ELEMENTS[27264] = Fluid3D([15258,15231,15193,14575],0); -ELEMENTS[27265] = Fluid3D([16440,15868,16070,16085],0); -ELEMENTS[27266] = Fluid3D([15868,16070,16085,15524],0); -ELEMENTS[27267] = Fluid3D([16070,16085,15524,16241],0); -ELEMENTS[27268] = Fluid3D([16070,16440,16085,16508],0); -ELEMENTS[27269] = Fluid3D([16440,16085,16508,16612],0); -ELEMENTS[27270] = Fluid3D([16508,16440,16612,17190],0); -ELEMENTS[27271] = Fluid3D([16440,16085,16612,16173],0); -ELEMENTS[27272] = Fluid3D([16440,15868,16085,16173],0); -ELEMENTS[27273] = Fluid3D([15868,16070,15524,15588],0); -ELEMENTS[27274] = Fluid3D([16085,16070,16508,16241],0); -ELEMENTS[27275] = Fluid3D([16508,16085,16241,16612],0); -ELEMENTS[27276] = Fluid3D([16070,16440,16508,16628],0); -ELEMENTS[27277] = Fluid3D([16085,15868,15524,15580],0); -ELEMENTS[27278] = Fluid3D([15868,15524,15580,15076],0); -ELEMENTS[27279] = Fluid3D([15524,16085,15580,15829],0); -ELEMENTS[27280] = Fluid3D([16085,15580,15829,16384],0); -ELEMENTS[27281] = Fluid3D([15524,16085,15829,15624],0); -ELEMENTS[27282] = Fluid3D([16085,15868,15580,16173],0); -ELEMENTS[27283] = Fluid3D([15193,15231,15588,15076],0); -ELEMENTS[27284] = Fluid3D([15231,15790,15588,15898],0); -ELEMENTS[27285] = Fluid3D([15790,15588,15898,16186],0); -ELEMENTS[27286] = Fluid3D([15231,15790,15898,15700],0); -ELEMENTS[27287] = Fluid3D([15588,15231,15898,15347],0); -ELEMENTS[27288] = Fluid3D([15588,15231,15347,15076],0); -ELEMENTS[27289] = Fluid3D([15231,15898,15347,15476],0); -ELEMENTS[27290] = Fluid3D([15898,15347,15476,15905],0); -ELEMENTS[27291] = Fluid3D([15476,15898,15905,15980],0); -ELEMENTS[27292] = Fluid3D([15905,15476,15980,15489],0); -ELEMENTS[27293] = Fluid3D([15980,15905,15489,15926],0); -ELEMENTS[27294] = Fluid3D([15489,15980,15926,15595],0); -ELEMENTS[27295] = Fluid3D([15926,15489,15595,15540],0); -ELEMENTS[27296] = Fluid3D([15905,15489,15926,15556],0); -ELEMENTS[27297] = Fluid3D([15489,15926,15556,15368],0); -ELEMENTS[27298] = Fluid3D([15489,15926,15368,15540],0); -ELEMENTS[27299] = Fluid3D([15926,15368,15540,15890],0); -ELEMENTS[27300] = Fluid3D([15368,15540,15890,15504],0); -ELEMENTS[27301] = Fluid3D([15556,15489,15368,14618],0); -ELEMENTS[27302] = Fluid3D([15489,15980,15595,15476],0); -ELEMENTS[27303] = Fluid3D([15905,15489,15556,15347],0); -ELEMENTS[27304] = Fluid3D([15926,15556,15368,15890],0); -ELEMENTS[27305] = Fluid3D([15368,15489,15540,14958],0); -ELEMENTS[27306] = Fluid3D([15540,15368,14958,14955],0); -ELEMENTS[27307] = Fluid3D([15540,15368,14955,15504],0); -ELEMENTS[27308] = Fluid3D([15368,14958,14955,14695],0); -ELEMENTS[27309] = Fluid3D([15368,14958,14695,15489],0); -ELEMENTS[27310] = Fluid3D([14955,15368,14695,15128],0); -ELEMENTS[27311] = Fluid3D([14955,15368,15128,15504],0); -ELEMENTS[27312] = Fluid3D([15368,14695,15128,14618],0); -ELEMENTS[27313] = Fluid3D([15905,15476,15489,15347],0); -ELEMENTS[27314] = Fluid3D([14695,14955,15128,14218],0); -ELEMENTS[27315] = Fluid3D([14955,15128,14218,14986],0); -ELEMENTS[27316] = Fluid3D([14955,15128,14986,15504],0); -ELEMENTS[27317] = Fluid3D([14986,14955,15504,15123],0); -ELEMENTS[27318] = Fluid3D([14218,14955,14986,14415],0); -ELEMENTS[27319] = Fluid3D([14955,14986,14415,15123],0); -ELEMENTS[27320] = Fluid3D([14958,14955,14695,14078],0); -ELEMENTS[27321] = Fluid3D([14695,14958,14078,14085],0); -ELEMENTS[27322] = Fluid3D([14695,14958,14085,15489],0); -ELEMENTS[27323] = Fluid3D([14955,14695,14078,14218],0); -ELEMENTS[27324] = Fluid3D([15128,14695,14218,14673],0); -ELEMENTS[27325] = Fluid3D([14218,15128,14673,14645],0); -ELEMENTS[27326] = Fluid3D([15128,14695,14673,14618],0); -ELEMENTS[27327] = Fluid3D([14695,14673,14618,13841],0); -ELEMENTS[27328] = Fluid3D([14695,14218,14673,13841],0); -ELEMENTS[27329] = Fluid3D([14695,14218,13841,14078],0); -ELEMENTS[27330] = Fluid3D([14218,14673,13841,13930],0); -ELEMENTS[27331] = Fluid3D([13841,14218,13930,13137],0); -ELEMENTS[27332] = Fluid3D([14218,14673,13930,14645],0); -ELEMENTS[27333] = Fluid3D([14618,14695,13841,14085],0); -ELEMENTS[27334] = Fluid3D([13841,14695,14078,14085],0); -ELEMENTS[27335] = Fluid3D([15128,14218,14986,14645],0); -ELEMENTS[27336] = Fluid3D([14218,14955,14415,14078],0); -ELEMENTS[27337] = Fluid3D([15347,15231,15476,14816],0); -ELEMENTS[27338] = Fluid3D([15231,15898,15476,15700],0); -ELEMENTS[27339] = Fluid3D([15231,15476,14816,14946],0); -ELEMENTS[27340] = Fluid3D([14958,14955,14078,14795],0); -ELEMENTS[27341] = Fluid3D([14078,14958,14795,13882],0); -ELEMENTS[27342] = Fluid3D([14955,14078,14795,14415],0); -ELEMENTS[27343] = Fluid3D([14958,15540,14955,14795],0); -ELEMENTS[27344] = Fluid3D([15898,15347,15905,16070],0); -ELEMENTS[27345] = Fluid3D([14618,14695,14085,15489],0); -ELEMENTS[27346] = Fluid3D([14958,14078,14085,13882],0); -ELEMENTS[27347] = Fluid3D([14078,14085,13882,13269],0); -ELEMENTS[27348] = Fluid3D([14986,14218,14415,14258],0); -ELEMENTS[27349] = Fluid3D([14218,14415,14258,13826],0); -ELEMENTS[27350] = Fluid3D([14415,14986,14258,15123],0); -ELEMENTS[27351] = Fluid3D([14415,14258,13826,13406],0); -ELEMENTS[27352] = Fluid3D([14986,14218,14258,14645],0); -ELEMENTS[27353] = Fluid3D([14218,14415,13826,14078],0); -ELEMENTS[27354] = Fluid3D([14258,14218,13826,13435],0); -ELEMENTS[27355] = Fluid3D([15898,15588,15347,16070],0); -ELEMENTS[27356] = Fluid3D([15476,15347,14816,15489],0); -ELEMENTS[27357] = Fluid3D([15791,15868,16173,15580],0); -ELEMENTS[27358] = Fluid3D([15347,15231,14816,14803],0); -ELEMENTS[27359] = Fluid3D([15347,15231,14803,15076],0); -ELEMENTS[27360] = Fluid3D([15231,14816,14803,14515],0); -ELEMENTS[27361] = Fluid3D([14816,14803,14515,14126],0); -ELEMENTS[27362] = Fluid3D([14816,14803,14126,14696],0); -ELEMENTS[27363] = Fluid3D([14803,14126,14696,14246],0); -ELEMENTS[27364] = Fluid3D([14803,14515,14126,14257],0); -ELEMENTS[27365] = Fluid3D([14803,14515,14257,15193],0); -ELEMENTS[27366] = Fluid3D([14816,15347,14803,14696],0); -ELEMENTS[27367] = Fluid3D([15231,14816,14515,14946],0); -ELEMENTS[27368] = Fluid3D([14126,14816,14696,13776],0); -ELEMENTS[27369] = Fluid3D([14803,15231,14515,15193],0); -ELEMENTS[27370] = Fluid3D([14515,14816,14126,14358],0); -ELEMENTS[27371] = Fluid3D([16738,16703,16718,17233],0); -ELEMENTS[27372] = Fluid3D([10119,11159,10673,10789],0); -ELEMENTS[27373] = Fluid3D([10673,10119,10789,9529],0); -ELEMENTS[27374] = Fluid3D([10119,11159,10789,10867],0); -ELEMENTS[27375] = Fluid3D([11159,10673,10789,11590],0); -ELEMENTS[27376] = Fluid3D([10673,10789,11590,10903],0); -ELEMENTS[27377] = Fluid3D([11159,10673,11590,11020],0); -ELEMENTS[27378] = Fluid3D([10789,11159,11590,11707],0); -ELEMENTS[27379] = Fluid3D([10789,11590,10903,11534],0); -ELEMENTS[27380] = Fluid3D([10903,10789,11534,10116],0); -ELEMENTS[27381] = Fluid3D([10903,10789,10116,10673],0); -ELEMENTS[27382] = Fluid3D([11590,10789,11707,11534],0); -ELEMENTS[27383] = Fluid3D([10789,11159,11707,10867],0); -ELEMENTS[27384] = Fluid3D([11590,10673,10903,11341],0); -ELEMENTS[27385] = Fluid3D([11590,10673,11341,11020],0); -ELEMENTS[27386] = Fluid3D([10673,11341,11020,10399],0); -ELEMENTS[27387] = Fluid3D([11020,10673,10399,9464],0); -ELEMENTS[27388] = Fluid3D([11341,11020,10399,11105],0); -ELEMENTS[27389] = Fluid3D([10673,11341,10399,10903],0); -ELEMENTS[27390] = Fluid3D([10903,11590,11341,11475],0); -ELEMENTS[27391] = Fluid3D([11159,11590,11707,12078],0); -ELEMENTS[27392] = Fluid3D([11159,11590,12078,11551],0); -ELEMENTS[27393] = Fluid3D([11707,11159,12078,12427],0); -ELEMENTS[27394] = Fluid3D([12078,11707,12427,12578],0); -ELEMENTS[27395] = Fluid3D([12427,12078,12578,13170],0); -ELEMENTS[27396] = Fluid3D([12427,12078,13170,12408],0); -ELEMENTS[27397] = Fluid3D([12427,12078,12408,11607],0); -ELEMENTS[27398] = Fluid3D([12078,12408,11607,11551],0); -ELEMENTS[27399] = Fluid3D([12427,12078,11607,11159],0); -ELEMENTS[27400] = Fluid3D([12078,11607,11159,11551],0); -ELEMENTS[27401] = Fluid3D([12078,12578,13170,12408],0); -ELEMENTS[27402] = Fluid3D([12078,12578,12408,11551],0); -ELEMENTS[27403] = Fluid3D([11590,11707,12078,12578],0); -ELEMENTS[27404] = Fluid3D([12078,11590,12578,11551],0); -ELEMENTS[27405] = Fluid3D([11590,10903,11534,11815],0); -ELEMENTS[27406] = Fluid3D([10903,11534,11815,10921],0); -ELEMENTS[27407] = Fluid3D([11534,11815,10921,11044],0); -ELEMENTS[27408] = Fluid3D([10903,11534,10921,10116],0); -ELEMENTS[27409] = Fluid3D([10921,10903,10116,10429],0); -ELEMENTS[27410] = Fluid3D([4620,5013,4840,4843],0); -ELEMENTS[27411] = Fluid3D([5013,4840,4843,5494],0); -ELEMENTS[27412] = Fluid3D([18034,17891,17835,18006],0); -ELEMENTS[27413] = Fluid3D([17891,17835,18006,17545],0); -ELEMENTS[27414] = Fluid3D([12354,12626,13276,12674],0); -ELEMENTS[27415] = Fluid3D([12354,12626,12674,11549],0); -ELEMENTS[27416] = Fluid3D([12626,13276,12674,13518],0); -ELEMENTS[27417] = Fluid3D([13276,12354,12674,12658],0); -ELEMENTS[27418] = Fluid3D([13276,12354,12658,12756],0); -ELEMENTS[27419] = Fluid3D([11530,11777,10964,11087],0); -ELEMENTS[27420] = Fluid3D([14509,14643,13869,14040],0); -ELEMENTS[27421] = Fluid3D([11461,11381,11580,10582],0); -ELEMENTS[27422] = Fluid3D([11580,11461,10582,12252],0); -ELEMENTS[27423] = Fluid3D([11461,11381,10582,10939],0); -ELEMENTS[27424] = Fluid3D([10582,11461,10939,11128],0); -ELEMENTS[27425] = Fluid3D([11461,11381,10939,11814],0); -ELEMENTS[27426] = Fluid3D([10939,11461,11814,11128],0); -ELEMENTS[27427] = Fluid3D([11381,10939,11814,11289],0); -ELEMENTS[27428] = Fluid3D([10939,11814,11289,11984],0); -ELEMENTS[27429] = Fluid3D([11814,11381,11289,12570],0); -ELEMENTS[27430] = Fluid3D([16059,15702,15477,16051],0); -ELEMENTS[27431] = Fluid3D([4237,4723,4451,4650],0); -ELEMENTS[27432] = Fluid3D([4723,4451,4650,5223],0); -ELEMENTS[27433] = Fluid3D([4451,4237,4650,4121],0); -ELEMENTS[27434] = Fluid3D([4650,4451,4121,4314],0); -ELEMENTS[27435] = Fluid3D([16576,16729,16213,16551],0); -ELEMENTS[27436] = Fluid3D([16576,16729,16551,16972],0); -ELEMENTS[27437] = Fluid3D([16213,16576,16551,16155],0); -ELEMENTS[27438] = Fluid3D([16729,16213,16551,16582],0); -ELEMENTS[27439] = Fluid3D([3404,3600,3794,3179],0); -ELEMENTS[27440] = Fluid3D([12715,11680,12107,12074],0); -ELEMENTS[27441] = Fluid3D([7507,7007,6793,7587],0); -ELEMENTS[27442] = Fluid3D([11167,11478,10800,11887],0); -ELEMENTS[27443] = Fluid3D([16668,17094,17183,17127],0); -ELEMENTS[27444] = Fluid3D([17094,17183,17127,17459],0); -ELEMENTS[27445] = Fluid3D([17183,17127,17459,17262],0); -ELEMENTS[27446] = Fluid3D([17127,17459,17262,17169],0); -ELEMENTS[27447] = Fluid3D([17127,17459,17169,17368],0); -ELEMENTS[27448] = Fluid3D([17183,16668,17127,16948],0); -ELEMENTS[27449] = Fluid3D([17183,16668,16948,16806],0); -ELEMENTS[27450] = Fluid3D([17127,17183,16948,17262],0); -ELEMENTS[27451] = Fluid3D([16948,17127,17262,17169],0); -ELEMENTS[27452] = Fluid3D([16668,17094,17127,16778],0); -ELEMENTS[27453] = Fluid3D([16668,17127,16948,16732],0); -ELEMENTS[27454] = Fluid3D([17127,16948,16732,17169],0); -ELEMENTS[27455] = Fluid3D([16732,17127,17169,16869],0); -ELEMENTS[27456] = Fluid3D([17127,17169,16869,17368],0); -ELEMENTS[27457] = Fluid3D([16732,17127,16869,16778],0); -ELEMENTS[27458] = Fluid3D([17127,16869,16778,17181],0); -ELEMENTS[27459] = Fluid3D([16869,16778,17181,16943],0); -ELEMENTS[27460] = Fluid3D([16869,16778,16943,16500],0); -ELEMENTS[27461] = Fluid3D([17181,16869,16943,17368],0); -ELEMENTS[27462] = Fluid3D([17181,16869,17368,17127],0); -ELEMENTS[27463] = Fluid3D([16778,17181,16943,16772],0); -ELEMENTS[27464] = Fluid3D([16668,17127,16732,16778],0); -ELEMENTS[27465] = Fluid3D([16948,16668,16732,16372],0); -ELEMENTS[27466] = Fluid3D([16869,16732,16778,16426],0); -ELEMENTS[27467] = Fluid3D([16732,16778,16426,16668],0); -ELEMENTS[27468] = Fluid3D([16869,16732,16426,16858],0); -ELEMENTS[27469] = Fluid3D([16426,16732,16668,16372],0); -ELEMENTS[27470] = Fluid3D([15145,14432,14421,15021],0); -ELEMENTS[27471] = Fluid3D([10243,9428,10252,9668],0); -ELEMENTS[27472] = Fluid3D([9013,8412,8006,9306],0); -ELEMENTS[27473] = Fluid3D([6788,6314,6005,6020],0); -ELEMENTS[27474] = Fluid3D([14725,14670,14881,15326],0); -ELEMENTS[27475] = Fluid3D([14670,14881,15326,15062],0); -ELEMENTS[27476] = Fluid3D([14881,14725,15326,15319],0); -ELEMENTS[27477] = Fluid3D([14725,14670,15326,15055],0); -ELEMENTS[27478] = Fluid3D([12159,13092,12813,12302],0); -ELEMENTS[27479] = Fluid3D([5845,5525,5684,6412],0); -ELEMENTS[27480] = Fluid3D([10928,11637,11790,11042],0); -ELEMENTS[27481] = Fluid3D([13400,12773,12788,12191],0); -ELEMENTS[27482] = Fluid3D([16636,16616,16263,16984],0); -ELEMENTS[27483] = Fluid3D([16636,16616,16984,16728],0); -ELEMENTS[27484] = Fluid3D([16984,16636,16728,17170],0); -ELEMENTS[27485] = Fluid3D([16984,16636,17170,17243],0); -ELEMENTS[27486] = Fluid3D([8843,8308,8545,9135],0); -ELEMENTS[27487] = Fluid3D([15625,15710,15802,15221],0); -ELEMENTS[27488] = Fluid3D([15802,15625,15221,15840],0); -ELEMENTS[27489] = Fluid3D([16625,16077,16275,16209],0); -ELEMENTS[27490] = Fluid3D([13454,12795,12980,12220],0); -ELEMENTS[27491] = Fluid3D([5201,5518,4887,4987],0); -ELEMENTS[27492] = Fluid3D([5518,4887,4987,5144],0); -ELEMENTS[27493] = Fluid3D([5201,5518,4987,5611],0); -ELEMENTS[27494] = Fluid3D([4887,4987,5144,4462],0); -ELEMENTS[27495] = Fluid3D([4887,4987,4462,4552],0); -ELEMENTS[27496] = Fluid3D([4462,4887,4552,4496],0); -ELEMENTS[27497] = Fluid3D([4887,5201,4987,4552],0); -ELEMENTS[27498] = Fluid3D([5144,4887,4462,4891],0); -ELEMENTS[27499] = Fluid3D([4987,5518,5144,5045],0); -ELEMENTS[27500] = Fluid3D([5144,4987,5045,4462],0); -ELEMENTS[27501] = Fluid3D([5518,4887,5144,5560],0); -ELEMENTS[27502] = Fluid3D([4987,4462,4552,4404],0); -ELEMENTS[27503] = Fluid3D([4987,4462,4404,5045],0); -ELEMENTS[27504] = Fluid3D([4462,4552,4404,4031],0); -ELEMENTS[27505] = Fluid3D([4552,4987,4404,4733],0); -ELEMENTS[27506] = Fluid3D([4552,4987,4733,5201],0); -ELEMENTS[27507] = Fluid3D([4987,4404,4733,5234],0); -ELEMENTS[27508] = Fluid3D([4404,4552,4733,4194],0); -ELEMENTS[27509] = Fluid3D([4404,4552,4194,4031],0); -ELEMENTS[27510] = Fluid3D([4552,4733,4194,4907],0); -ELEMENTS[27511] = Fluid3D([4552,4733,4907,5201],0); -ELEMENTS[27512] = Fluid3D([4733,4907,5201,5611],0); -ELEMENTS[27513] = Fluid3D([4907,4552,5201,4887],0); -ELEMENTS[27514] = Fluid3D([4733,4404,4194,4339],0); -ELEMENTS[27515] = Fluid3D([6515,6893,6130,6148],0); -ELEMENTS[27516] = Fluid3D([6893,6130,6148,6092],0); -ELEMENTS[27517] = Fluid3D([6130,6515,6148,5821],0); -ELEMENTS[27518] = Fluid3D([6130,6148,6092,5532],0); -ELEMENTS[27519] = Fluid3D([6515,6893,6148,6461],0); -ELEMENTS[27520] = Fluid3D([6893,6130,6092,6600],0); -ELEMENTS[27521] = Fluid3D([6148,6893,6092,6862],0); -ELEMENTS[27522] = Fluid3D([6893,6092,6862,6868],0); -ELEMENTS[27523] = Fluid3D([6148,6893,6862,7491],0); -ELEMENTS[27524] = Fluid3D([6092,6148,6862,5955],0); -ELEMENTS[27525] = Fluid3D([6092,6148,5955,5537],0); -ELEMENTS[27526] = Fluid3D([6148,6862,5955,6349],0); -ELEMENTS[27527] = Fluid3D([6862,5955,6349,6253],0); -ELEMENTS[27528] = Fluid3D([6148,6862,6349,7491],0); -ELEMENTS[27529] = Fluid3D([6148,5955,5537,5369],0); -ELEMENTS[27530] = Fluid3D([5955,6148,6349,5369],0); -ELEMENTS[27531] = Fluid3D([6862,6092,5955,6264],0); -ELEMENTS[27532] = Fluid3D([6092,5955,6264,5731],0); -ELEMENTS[27533] = Fluid3D([5955,6264,5731,5696],0); -ELEMENTS[27534] = Fluid3D([5731,5955,5696,5295],0); -ELEMENTS[27535] = Fluid3D([5955,6264,5696,6253],0); -ELEMENTS[27536] = Fluid3D([5696,5955,6253,5295],0); -ELEMENTS[27537] = Fluid3D([5955,6264,6253,6862],0); -ELEMENTS[27538] = Fluid3D([6264,5731,5696,5771],0); -ELEMENTS[27539] = Fluid3D([5731,5696,5771,5223],0); -ELEMENTS[27540] = Fluid3D([6264,6092,5731,6166],0); -ELEMENTS[27541] = Fluid3D([6862,6092,6264,6868],0); -ELEMENTS[27542] = Fluid3D([6264,6092,6166,6868],0); -ELEMENTS[27543] = Fluid3D([6166,6264,6868,6615],0); -ELEMENTS[27544] = Fluid3D([5731,6264,6166,5771],0); -ELEMENTS[27545] = Fluid3D([6166,5731,5771,5640],0); -ELEMENTS[27546] = Fluid3D([5731,5771,5640,5223],0); -ELEMENTS[27547] = Fluid3D([6092,5955,5731,5537],0); -ELEMENTS[27548] = Fluid3D([5696,5731,5295,5223],0); -ELEMENTS[27549] = Fluid3D([6092,5731,6166,5718],0); -ELEMENTS[27550] = Fluid3D([6166,6092,5718,6600],0); -ELEMENTS[27551] = Fluid3D([6092,5731,5718,5537],0); -ELEMENTS[27552] = Fluid3D([6166,5731,5640,5718],0); -ELEMENTS[27553] = Fluid3D([5731,5640,5718,5223],0); -ELEMENTS[27554] = Fluid3D([5955,5731,5537,5295],0); -ELEMENTS[27555] = Fluid3D([6092,6166,6868,6600],0); -ELEMENTS[27556] = Fluid3D([6092,6148,5537,5532],0); -ELEMENTS[27557] = Fluid3D([5537,6092,5532,5718],0); -ELEMENTS[27558] = Fluid3D([5532,5537,5718,4827],0); -ELEMENTS[27559] = Fluid3D([6092,5532,5718,6600],0); -ELEMENTS[27560] = Fluid3D([5640,6166,5718,5887],0); -ELEMENTS[27561] = Fluid3D([2300,2482,2214,2257],0); -ELEMENTS[27562] = Fluid3D([9510,9217,10142,9962],0); -ELEMENTS[27563] = Fluid3D([18472,18485,18583,18451],0); -ELEMENTS[27564] = Fluid3D([18472,18485,18451,18333],0); -ELEMENTS[27565] = Fluid3D([18485,18583,18451,18585],0); -ELEMENTS[27566] = Fluid3D([18583,18472,18451,18544],0); -ELEMENTS[27567] = Fluid3D([18451,18583,18544,18585],0); -ELEMENTS[27568] = Fluid3D([8580,9141,8587,8184],0); -ELEMENTS[27569] = Fluid3D([9141,8587,8184,8642],0); -ELEMENTS[27570] = Fluid3D([8587,8580,8184,7772],0); -ELEMENTS[27571] = Fluid3D([8587,8580,7772,8395],0); -ELEMENTS[27572] = Fluid3D([8184,8587,7772,7756],0); -ELEMENTS[27573] = Fluid3D([7772,8587,8395,7990],0); -ELEMENTS[27574] = Fluid3D([7772,8587,7990,7756],0); -ELEMENTS[27575] = Fluid3D([8580,9141,8184,8693],0); -ELEMENTS[27576] = Fluid3D([8587,8395,7990,8977],0); -ELEMENTS[27577] = Fluid3D([8587,8395,8977,8580],0); -ELEMENTS[27578] = Fluid3D([8395,7990,8977,8505],0); -ELEMENTS[27579] = Fluid3D([7990,8587,8977,9226],0); -ELEMENTS[27580] = Fluid3D([8580,7772,8395,7934],0); -ELEMENTS[27581] = Fluid3D([8395,8580,7934,9348],0); -ELEMENTS[27582] = Fluid3D([8580,7772,7934,7668],0); -ELEMENTS[27583] = Fluid3D([7772,7934,7668,7198],0); -ELEMENTS[27584] = Fluid3D([7772,7934,7198,7588],0); -ELEMENTS[27585] = Fluid3D([7198,7772,7588,6928],0); -ELEMENTS[27586] = Fluid3D([7668,7772,7198,7195],0); -ELEMENTS[27587] = Fluid3D([7934,7668,7198,7225],0); -ELEMENTS[27588] = Fluid3D([7934,8580,7668,8212],0); -ELEMENTS[27589] = Fluid3D([7668,7934,8212,7728],0); -ELEMENTS[27590] = Fluid3D([8580,7668,8212,8001],0); -ELEMENTS[27591] = Fluid3D([7668,8212,8001,7722],0); -ELEMENTS[27592] = Fluid3D([8212,8001,7722,8489],0); -ELEMENTS[27593] = Fluid3D([8001,7668,7722,7195],0); -ELEMENTS[27594] = Fluid3D([8001,7722,8489,8693],0); -ELEMENTS[27595] = Fluid3D([8001,7722,8693,8298],0); -ELEMENTS[27596] = Fluid3D([8693,8001,8298,8184],0); -ELEMENTS[27597] = Fluid3D([7198,7772,6928,7292],0); -ELEMENTS[27598] = Fluid3D([8693,8001,8184,8580],0); -ELEMENTS[27599] = Fluid3D([7772,7934,7588,8395],0); -ELEMENTS[27600] = Fluid3D([7588,7772,8395,7990],0); -ELEMENTS[27601] = Fluid3D([7588,7772,7990,6928],0); -ELEMENTS[27602] = Fluid3D([8395,7588,7990,8505],0); -ELEMENTS[27603] = Fluid3D([7934,7588,8395,7818],0); -ELEMENTS[27604] = Fluid3D([8580,8184,7772,7668],0); -ELEMENTS[27605] = Fluid3D([15002,14269,14892,14788],0); -ELEMENTS[27606] = Fluid3D([17615,17832,17740,17939],0); -ELEMENTS[27607] = Fluid3D([9358,8589,8850,9481],0); -ELEMENTS[27608] = Fluid3D([13539,12931,13282,12423],0); -ELEMENTS[27609] = Fluid3D([9482,10147,10349,10335],0); -ELEMENTS[27610] = Fluid3D([10147,10349,10335,11381],0); -ELEMENTS[27611] = Fluid3D([10349,9482,10335,10208],0); -ELEMENTS[27612] = Fluid3D([9482,10147,10335,9353],0); -ELEMENTS[27613] = Fluid3D([10335,10349,10208,11289],0); -ELEMENTS[27614] = Fluid3D([10349,9482,10208,10317],0); -ELEMENTS[27615] = Fluid3D([10208,10349,10317,11223],0); -ELEMENTS[27616] = Fluid3D([10317,10208,11223,11022],0); -ELEMENTS[27617] = Fluid3D([9482,10335,10208,9642],0); -ELEMENTS[27618] = Fluid3D([9482,10335,9642,9353],0); -ELEMENTS[27619] = Fluid3D([10335,10208,9642,11040],0); -ELEMENTS[27620] = Fluid3D([10208,9482,9642,9412],0); -ELEMENTS[27621] = Fluid3D([10208,9482,9412,10317],0); -ELEMENTS[27622] = Fluid3D([9412,10208,10317,10066],0); -ELEMENTS[27623] = Fluid3D([9412,10208,10066,9642],0); -ELEMENTS[27624] = Fluid3D([10208,10066,9642,11040],0); -ELEMENTS[27625] = Fluid3D([10208,10317,10066,11022],0); -ELEMENTS[27626] = Fluid3D([13249,13189,13845,13917],0); -ELEMENTS[27627] = Fluid3D([8030,8466,8871,8304],0); -ELEMENTS[27628] = Fluid3D([5664,6179,5552,6109],0); -ELEMENTS[27629] = Fluid3D([6179,5552,6109,5944],0); -ELEMENTS[27630] = Fluid3D([13415,13253,13445,14137],0); -ELEMENTS[27631] = Fluid3D([7850,8348,8634,7776],0); -ELEMENTS[27632] = Fluid3D([14821,14299,14872,14848],0); -ELEMENTS[27633] = Fluid3D([15351,15553,15545,16098],0); -ELEMENTS[27634] = Fluid3D([9901,9770,10269,9259],0); -ELEMENTS[27635] = Fluid3D([10269,9901,9259,10325],0); -ELEMENTS[27636] = Fluid3D([9901,9770,9259,9086],0); -ELEMENTS[27637] = Fluid3D([9770,10269,9259,9701],0); -ELEMENTS[27638] = Fluid3D([4302,4550,4968,4385],0); -ELEMENTS[27639] = Fluid3D([4302,4550,4385,4047],0); -ELEMENTS[27640] = Fluid3D([10454,11374,10278,9960],0); -ELEMENTS[27641] = Fluid3D([9972,10889,10558,9904],0); -ELEMENTS[27642] = Fluid3D([13906,13790,14484,13836],0); -ELEMENTS[27643] = Fluid3D([8455,8388,7692,8820],0); -ELEMENTS[27644] = Fluid3D([7466,8314,7866,7967],0); -ELEMENTS[27645] = Fluid3D([14901,14207,14801,14494],0); -ELEMENTS[27646] = Fluid3D([16481,17028,16819,16806],0); -ELEMENTS[27647] = Fluid3D([5669,5932,5847,5329],0); -ELEMENTS[27648] = Fluid3D([5847,5669,5329,5303],0); -ELEMENTS[27649] = Fluid3D([5847,5669,5303,5778],0); -ELEMENTS[27650] = Fluid3D([5669,5329,5303,5073],0); -ELEMENTS[27651] = Fluid3D([5303,5669,5073,5367],0); -ELEMENTS[27652] = Fluid3D([5669,5073,5367,4965],0); -ELEMENTS[27653] = Fluid3D([5073,5367,4965,4806],0); -ELEMENTS[27654] = Fluid3D([5329,5847,5303,5229],0); -ELEMENTS[27655] = Fluid3D([5847,5303,5229,5824],0); -ELEMENTS[27656] = Fluid3D([5669,5329,5073,5543],0); -ELEMENTS[27657] = Fluid3D([5329,5847,5229,5454],0); -ELEMENTS[27658] = Fluid3D([5669,5932,5329,5543],0); -ELEMENTS[27659] = Fluid3D([5329,5303,5073,4564],0); -ELEMENTS[27660] = Fluid3D([5303,5073,4564,4894],0); -ELEMENTS[27661] = Fluid3D([5073,4564,4894,4806],0); -ELEMENTS[27662] = Fluid3D([5303,5073,4894,5367],0); -ELEMENTS[27663] = Fluid3D([5303,5329,5229,4798],0); -ELEMENTS[27664] = Fluid3D([5932,5847,5329,5454],0); -ELEMENTS[27665] = Fluid3D([6908,6178,6590,7185],0); -ELEMENTS[27666] = Fluid3D([6668,6522,6102,5817],0); -ELEMENTS[27667] = Fluid3D([6102,6668,5817,6141],0); -ELEMENTS[27668] = Fluid3D([6668,5817,6141,6216],0); -ELEMENTS[27669] = Fluid3D([6141,6668,6216,6231],0); -ELEMENTS[27670] = Fluid3D([6102,6668,6141,6431],0); -ELEMENTS[27671] = Fluid3D([6668,5817,6216,6536],0); -ELEMENTS[27672] = Fluid3D([6216,6668,6536,7260],0); -ELEMENTS[27673] = Fluid3D([6668,5817,6536,6522],0); -ELEMENTS[27674] = Fluid3D([6536,6668,6522,7287],0); -ELEMENTS[27675] = Fluid3D([6522,6536,7287,7231],0); -ELEMENTS[27676] = Fluid3D([5817,6536,6522,6061],0); -ELEMENTS[27677] = Fluid3D([6536,6522,6061,7231],0); -ELEMENTS[27678] = Fluid3D([6536,6668,7287,7260],0); -ELEMENTS[27679] = Fluid3D([6522,5817,6061,5882],0); -ELEMENTS[27680] = Fluid3D([6061,6522,5882,6350],0); -ELEMENTS[27681] = Fluid3D([6061,6522,6350,7231],0); -ELEMENTS[27682] = Fluid3D([6522,5882,6350,6808],0); -ELEMENTS[27683] = Fluid3D([5882,6061,6350,5625],0); -ELEMENTS[27684] = Fluid3D([6061,6350,5625,6229],0); -ELEMENTS[27685] = Fluid3D([6061,6350,6229,7231],0); -ELEMENTS[27686] = Fluid3D([5625,6061,6229,5531],0); -ELEMENTS[27687] = Fluid3D([5882,6061,5625,5520],0); -ELEMENTS[27688] = Fluid3D([5882,6061,5520,5817],0); -ELEMENTS[27689] = Fluid3D([6061,5625,5520,5531],0); -ELEMENTS[27690] = Fluid3D([6522,5817,5882,6102],0); -ELEMENTS[27691] = Fluid3D([6350,5625,6229,6682],0); -ELEMENTS[27692] = Fluid3D([6229,6350,6682,7231],0); -ELEMENTS[27693] = Fluid3D([5625,5882,5520,5070],0); -ELEMENTS[27694] = Fluid3D([6350,5882,5625,5649],0); -ELEMENTS[27695] = Fluid3D([5817,6536,6061,5606],0); -ELEMENTS[27696] = Fluid3D([14290,14186,13623,14559],0); -ELEMENTS[27697] = Fluid3D([13623,14290,14559,14543],0); -ELEMENTS[27698] = Fluid3D([14290,14186,14559,15134],0); -ELEMENTS[27699] = Fluid3D([14290,14559,14543,15339],0); -ELEMENTS[27700] = Fluid3D([13623,14290,14543,13584],0); -ELEMENTS[27701] = Fluid3D([14543,13623,13584,13265],0); -ELEMENTS[27702] = Fluid3D([14290,14543,13584,14327],0); -ELEMENTS[27703] = Fluid3D([14290,14543,14327,15339],0); -ELEMENTS[27704] = Fluid3D([13623,14290,13584,13557],0); -ELEMENTS[27705] = Fluid3D([13584,14290,14327,13928],0); -ELEMENTS[27706] = Fluid3D([14290,14327,13928,14855],0); -ELEMENTS[27707] = Fluid3D([14290,14327,14855,15339],0); -ELEMENTS[27708] = Fluid3D([13584,14290,13928,13557],0); -ELEMENTS[27709] = Fluid3D([14327,13584,13928,13619],0); -ELEMENTS[27710] = Fluid3D([13584,13928,13619,13044],0); -ELEMENTS[27711] = Fluid3D([13619,13584,13044,12644],0); -ELEMENTS[27712] = Fluid3D([13584,13044,12644,13019],0); -ELEMENTS[27713] = Fluid3D([13044,12644,13019,12755],0); -ELEMENTS[27714] = Fluid3D([13019,13044,12755,13557],0); -ELEMENTS[27715] = Fluid3D([12755,13019,13557,12886],0); -ELEMENTS[27716] = Fluid3D([13019,13557,12886,13322],0); -ELEMENTS[27717] = Fluid3D([12755,13019,12886,12359],0); -ELEMENTS[27718] = Fluid3D([12755,13019,12359,12644],0); -ELEMENTS[27719] = Fluid3D([13019,12359,12644,13008],0); -ELEMENTS[27720] = Fluid3D([13019,12359,13008,12643],0); -ELEMENTS[27721] = Fluid3D([13044,12644,12755,12496],0); -ELEMENTS[27722] = Fluid3D([12755,13044,12496,13494],0); -ELEMENTS[27723] = Fluid3D([13044,12644,12496,12961],0); -ELEMENTS[27724] = Fluid3D([13044,12644,12961,13619],0); -ELEMENTS[27725] = Fluid3D([12961,13044,13619,13485],0); -ELEMENTS[27726] = Fluid3D([13619,12961,13485,13511],0); -ELEMENTS[27727] = Fluid3D([12496,13044,12961,13485],0); -ELEMENTS[27728] = Fluid3D([12644,13019,13008,13584],0); -ELEMENTS[27729] = Fluid3D([13019,13008,13584,13623],0); -ELEMENTS[27730] = Fluid3D([13008,13584,13623,13265],0); -ELEMENTS[27731] = Fluid3D([13008,13584,13265,12644],0); -ELEMENTS[27732] = Fluid3D([13019,12886,12359,12643],0); -ELEMENTS[27733] = Fluid3D([12359,12644,13008,11748],0); -ELEMENTS[27734] = Fluid3D([12496,13044,13485,13494],0); -ELEMENTS[27735] = Fluid3D([13044,13619,13485,13928],0); -ELEMENTS[27736] = Fluid3D([13019,13044,13557,13584],0); -ELEMENTS[27737] = Fluid3D([13557,13019,13584,13623],0); -ELEMENTS[27738] = Fluid3D([13557,13019,13623,13322],0); -ELEMENTS[27739] = Fluid3D([13619,13485,13928,14286],0); -ELEMENTS[27740] = Fluid3D([13619,13485,14286,13511],0); -ELEMENTS[27741] = Fluid3D([13928,14327,13619,14286],0); -ELEMENTS[27742] = Fluid3D([14327,13584,13619,14043],0); -ELEMENTS[27743] = Fluid3D([13584,13928,13044,13557],0); -ELEMENTS[27744] = Fluid3D([14559,13623,14543,14136],0); -ELEMENTS[27745] = Fluid3D([13623,14543,14136,13265],0); -ELEMENTS[27746] = Fluid3D([14543,14559,14136,14891],0); -ELEMENTS[27747] = Fluid3D([14136,14543,14891,14621],0); -ELEMENTS[27748] = Fluid3D([14136,14543,14621,14043],0); -ELEMENTS[27749] = Fluid3D([14136,14543,14043,13265],0); -ELEMENTS[27750] = Fluid3D([14559,14136,14891,13623],0); -ELEMENTS[27751] = Fluid3D([14186,13623,14559,13593],0); -ELEMENTS[27752] = Fluid3D([14543,13584,14327,14043],0); -ELEMENTS[27753] = Fluid3D([13156,13761,13172,14098],0); -ELEMENTS[27754] = Fluid3D([17108,16814,17070,16752],0); -ELEMENTS[27755] = Fluid3D([12683,13331,13556,13072],0); -ELEMENTS[27756] = Fluid3D([4741,4421,4251,4478],0); -ELEMENTS[27757] = Fluid3D([10160,10005,9424,10369],0); -ELEMENTS[27758] = Fluid3D([11690,11581,12113,12641],0); -ELEMENTS[27759] = Fluid3D([8704,9271,8546,9484],0); -ELEMENTS[27760] = Fluid3D([14049,13427,13783,12940],0); -ELEMENTS[27761] = Fluid3D([14238,14455,14952,14655],0); -ELEMENTS[27762] = Fluid3D([4330,4463,3816,4053],0); -ELEMENTS[27763] = Fluid3D([16787,16854,16362,16525],0); -ELEMENTS[27764] = Fluid3D([16362,16787,16525,16415],0); -ELEMENTS[27765] = Fluid3D([16787,16854,16525,17172],0); -ELEMENTS[27766] = Fluid3D([16854,16362,16525,16499],0); -ELEMENTS[27767] = Fluid3D([16362,16525,16499,16381],0); -ELEMENTS[27768] = Fluid3D([16854,16362,16499,16486],0); -ELEMENTS[27769] = Fluid3D([16525,16854,16499,16963],0); -ELEMENTS[27770] = Fluid3D([16854,16499,16963,16827],0); -ELEMENTS[27771] = Fluid3D([16525,16854,16963,17172],0); -ELEMENTS[27772] = Fluid3D([16499,16525,16963,16381],0); -ELEMENTS[27773] = Fluid3D([16499,16963,16827,16608],0); -ELEMENTS[27774] = Fluid3D([16963,16827,16608,17302],0); -ELEMENTS[27775] = Fluid3D([16499,16963,16608,16381],0); -ELEMENTS[27776] = Fluid3D([16963,16854,16827,17277],0); -ELEMENTS[27777] = Fluid3D([16854,16499,16827,16486],0); -ELEMENTS[27778] = Fluid3D([16827,16499,16608,16305],0); -ELEMENTS[27779] = Fluid3D([16827,16499,16305,16486],0); -ELEMENTS[27780] = Fluid3D([16499,16608,16305,16097],0); -ELEMENTS[27781] = Fluid3D([16608,16827,16305,16725],0); -ELEMENTS[27782] = Fluid3D([16608,16827,16725,17302],0); -ELEMENTS[27783] = Fluid3D([16827,16305,16725,16656],0); -ELEMENTS[27784] = Fluid3D([16725,16827,16656,17075],0); -ELEMENTS[27785] = Fluid3D([16827,16305,16656,16486],0); -ELEMENTS[27786] = Fluid3D([16656,16725,17075,16932],0); -ELEMENTS[27787] = Fluid3D([16656,16725,16932,16408],0); -ELEMENTS[27788] = Fluid3D([16725,16932,16408,16555],0); -ELEMENTS[27789] = Fluid3D([16725,17075,16932,17194],0); -ELEMENTS[27790] = Fluid3D([16725,16827,17075,17302],0); -ELEMENTS[27791] = Fluid3D([16656,16725,16408,16305],0); -ELEMENTS[27792] = Fluid3D([16932,16408,16555,16799],0); -ELEMENTS[27793] = Fluid3D([16725,16932,16555,17194],0); -ELEMENTS[27794] = Fluid3D([16932,16656,16408,16533],0); -ELEMENTS[27795] = Fluid3D([16408,16932,16533,16799],0); -ELEMENTS[27796] = Fluid3D([16656,16408,16533,16089],0); -ELEMENTS[27797] = Fluid3D([16656,16408,16089,16305],0); -ELEMENTS[27798] = Fluid3D([16932,16656,16533,16975],0); -ELEMENTS[27799] = Fluid3D([16533,16656,16089,16471],0); -ELEMENTS[27800] = Fluid3D([16533,16656,16471,16975],0); -ELEMENTS[27801] = Fluid3D([16089,16533,16471,16066],0); -ELEMENTS[27802] = Fluid3D([16089,16533,16066,15946],0); -ELEMENTS[27803] = Fluid3D([16089,16533,15946,16408],0); -ELEMENTS[27804] = Fluid3D([16533,16471,16066,16699],0); -ELEMENTS[27805] = Fluid3D([16533,16066,15946,16264],0); -ELEMENTS[27806] = Fluid3D([16533,16066,16264,16699],0); -ELEMENTS[27807] = Fluid3D([15946,16533,16264,16364],0); -ELEMENTS[27808] = Fluid3D([16066,15946,16264,15657],0); -ELEMENTS[27809] = Fluid3D([16066,15946,15657,15490],0); -ELEMENTS[27810] = Fluid3D([15946,16264,15657,15850],0); -ELEMENTS[27811] = Fluid3D([16264,15657,15850,15928],0); -ELEMENTS[27812] = Fluid3D([16066,15946,15490,16089],0); -ELEMENTS[27813] = Fluid3D([16533,16264,16364,16748],0); -ELEMENTS[27814] = Fluid3D([16533,16264,16748,16699],0); -ELEMENTS[27815] = Fluid3D([16264,16364,16748,16189],0); -ELEMENTS[27816] = Fluid3D([16264,15657,15928,16268],0); -ELEMENTS[27817] = Fluid3D([15928,16264,16268,16360],0); -ELEMENTS[27818] = Fluid3D([15946,16264,15850,16364],0); -ELEMENTS[27819] = Fluid3D([15657,15850,15928,15219],0); -ELEMENTS[27820] = Fluid3D([15657,15850,15219,15946],0); -ELEMENTS[27821] = Fluid3D([16656,16089,16471,16486],0); -ELEMENTS[27822] = Fluid3D([15946,15657,15490,15219],0); -ELEMENTS[27823] = Fluid3D([15657,15490,15219,15081],0); -ELEMENTS[27824] = Fluid3D([15219,15657,15081,15563],0); -ELEMENTS[27825] = Fluid3D([15219,15657,15563,15928],0); -ELEMENTS[27826] = Fluid3D([15657,15081,15563,16066],0); -ELEMENTS[27827] = Fluid3D([15657,15563,15928,16268],0); -ELEMENTS[27828] = Fluid3D([15657,15490,15081,16066],0); -ELEMENTS[27829] = Fluid3D([15946,16533,16364,16408],0); -ELEMENTS[27830] = Fluid3D([16471,16089,16066,15930],0); -ELEMENTS[27831] = Fluid3D([16089,16066,15930,15490],0); -ELEMENTS[27832] = Fluid3D([16471,16089,15930,16486],0); -ELEMENTS[27833] = Fluid3D([16066,16471,15930,16253],0); -ELEMENTS[27834] = Fluid3D([15930,16066,16253,15644],0); -ELEMENTS[27835] = Fluid3D([16066,16253,15644,16207],0); -ELEMENTS[27836] = Fluid3D([16066,16471,16253,16699],0); -ELEMENTS[27837] = Fluid3D([16253,15930,15644,15833],0); -ELEMENTS[27838] = Fluid3D([15644,16253,15833,15849],0); -ELEMENTS[27839] = Fluid3D([16253,15930,15833,16342],0); -ELEMENTS[27840] = Fluid3D([16253,15930,16342,16471],0); -ELEMENTS[27841] = Fluid3D([15833,16253,16342,16449],0); -ELEMENTS[27842] = Fluid3D([15930,15644,15833,15312],0); -ELEMENTS[27843] = Fluid3D([15644,15833,15312,15268],0); -ELEMENTS[27844] = Fluid3D([15312,15644,15268,15081],0); -ELEMENTS[27845] = Fluid3D([15644,15833,15268,15849],0); -ELEMENTS[27846] = Fluid3D([15644,15268,15081,15634],0); -ELEMENTS[27847] = Fluid3D([15644,15268,15634,15726],0); -ELEMENTS[27848] = Fluid3D([15833,15312,15268,15137],0); -ELEMENTS[27849] = Fluid3D([15930,15644,15312,15490],0); -ELEMENTS[27850] = Fluid3D([15930,15833,16342,15821],0); -ELEMENTS[27851] = Fluid3D([15930,15833,15821,15312],0); -ELEMENTS[27852] = Fluid3D([16342,15930,15821,16486],0); -ELEMENTS[27853] = Fluid3D([15833,16342,15821,16088],0); -ELEMENTS[27854] = Fluid3D([15833,16342,16088,16449],0); -ELEMENTS[27855] = Fluid3D([15821,15833,16088,15442],0); -ELEMENTS[27856] = Fluid3D([15821,15833,15442,15312],0); -ELEMENTS[27857] = Fluid3D([15833,16088,15442,15849],0); -ELEMENTS[27858] = Fluid3D([16342,15821,16088,16176],0); -ELEMENTS[27859] = Fluid3D([15930,16066,15644,15490],0); -ELEMENTS[27860] = Fluid3D([16088,15821,15442,15762],0); -ELEMENTS[27861] = Fluid3D([16088,15821,15762,16176],0); -ELEMENTS[27862] = Fluid3D([15821,15762,16176,15684],0); -ELEMENTS[27863] = Fluid3D([16176,15821,15684,15933],0); -ELEMENTS[27864] = Fluid3D([16176,15821,15933,16486],0); -ELEMENTS[27865] = Fluid3D([15821,15684,15933,15324],0); -ELEMENTS[27866] = Fluid3D([15933,16176,16486,16362],0); -ELEMENTS[27867] = Fluid3D([15821,15684,15324,15220],0); -ELEMENTS[27868] = Fluid3D([15821,15684,15220,15762],0); -ELEMENTS[27869] = Fluid3D([15933,15821,15324,15930],0); -ELEMENTS[27870] = Fluid3D([15684,16176,15933,16362],0); -ELEMENTS[27871] = Fluid3D([15220,15821,15762,15442],0); -ELEMENTS[27872] = Fluid3D([15762,15220,15442,15166],0); -ELEMENTS[27873] = Fluid3D([15220,15442,15166,14648],0); -ELEMENTS[27874] = Fluid3D([15166,15220,14648,14968],0); -ELEMENTS[27875] = Fluid3D([14648,15166,14968,15214],0); -ELEMENTS[27876] = Fluid3D([15220,15821,15442,15312],0); -ELEMENTS[27877] = Fluid3D([15166,15220,14968,15762],0); -ELEMENTS[27878] = Fluid3D([15166,14968,15214,15762],0); -ELEMENTS[27879] = Fluid3D([15220,14648,14968,14698],0); -ELEMENTS[27880] = Fluid3D([14648,14968,14698,14591],0); -ELEMENTS[27881] = Fluid3D([14648,14968,14591,15214],0); -ELEMENTS[27882] = Fluid3D([14968,14591,15214,15169],0); -ELEMENTS[27883] = Fluid3D([14968,14698,14591,14502],0); -ELEMENTS[27884] = Fluid3D([14591,14968,14502,15169],0); -ELEMENTS[27885] = Fluid3D([15220,15442,14648,14706],0); -ELEMENTS[27886] = Fluid3D([15220,14648,14698,14706],0); -ELEMENTS[27887] = Fluid3D([15442,15762,15166,15814],0); -ELEMENTS[27888] = Fluid3D([14968,14698,14502,14982],0); -ELEMENTS[27889] = Fluid3D([14502,14968,14982,15153],0); -ELEMENTS[27890] = Fluid3D([15324,15821,15220,15312],0); -ELEMENTS[27891] = Fluid3D([15324,15821,15312,15930],0); -ELEMENTS[27892] = Fluid3D([14968,14698,14982,15220],0); -ELEMENTS[27893] = Fluid3D([15442,15166,14648,14902],0); -ELEMENTS[27894] = Fluid3D([15166,14648,14902,14679],0); -ELEMENTS[27895] = Fluid3D([15166,14648,14679,15214],0); -ELEMENTS[27896] = Fluid3D([14902,15166,14679,15323],0); -ELEMENTS[27897] = Fluid3D([14902,15166,15323,15814],0); -ELEMENTS[27898] = Fluid3D([15166,14679,15323,15214],0); -ELEMENTS[27899] = Fluid3D([15442,15166,14902,15814],0); -ELEMENTS[27900] = Fluid3D([14679,14902,15323,15082],0); -ELEMENTS[27901] = Fluid3D([14902,15323,15082,15814],0); -ELEMENTS[27902] = Fluid3D([14679,14902,15082,14210],0); -ELEMENTS[27903] = Fluid3D([15323,14679,15082,14950],0); -ELEMENTS[27904] = Fluid3D([15082,15323,14950,15511],0); -ELEMENTS[27905] = Fluid3D([15082,15323,15511,15814],0); -ELEMENTS[27906] = Fluid3D([15323,14950,15511,15420],0); -ELEMENTS[27907] = Fluid3D([15511,15323,15420,16003],0); -ELEMENTS[27908] = Fluid3D([15511,15323,16003,15814],0); -ELEMENTS[27909] = Fluid3D([15420,15511,16003,16174],0); -ELEMENTS[27910] = Fluid3D([14950,15511,15420,15336],0); -ELEMENTS[27911] = Fluid3D([15323,14950,15420,14555],0); -ELEMENTS[27912] = Fluid3D([16003,15511,15814,15679],0); -ELEMENTS[27913] = Fluid3D([15511,15420,15336,16174],0); -ELEMENTS[27914] = Fluid3D([15684,15933,15324,15426],0); -ELEMENTS[27915] = Fluid3D([15933,15324,15426,15539],0); -ELEMENTS[27916] = Fluid3D([15933,15324,15539,15930],0); -ELEMENTS[27917] = Fluid3D([15324,15426,15539,14796],0); -ELEMENTS[27918] = Fluid3D([15324,15426,14796,14982],0); -ELEMENTS[27919] = Fluid3D([15684,15324,15220,14982],0); -ELEMENTS[27920] = Fluid3D([15324,15684,15426,14982],0); -ELEMENTS[27921] = Fluid3D([15684,15426,14982,15801],0); -ELEMENTS[27922] = Fluid3D([15220,15324,15312,14706],0); -ELEMENTS[27923] = Fluid3D([15684,15933,15426,15801],0); -ELEMENTS[27924] = Fluid3D([15684,15220,15762,14968],0); -ELEMENTS[27925] = Fluid3D([15442,16088,15762,15814],0); -ELEMENTS[27926] = Fluid3D([15426,15933,15539,15939],0); -ELEMENTS[27927] = Fluid3D([15933,15539,15939,16305],0); -ELEMENTS[27928] = Fluid3D([15539,15426,15939,15333],0); -ELEMENTS[27929] = Fluid3D([15426,15939,15333,15284],0); -ELEMENTS[27930] = Fluid3D([15333,15426,15284,14914],0); -ELEMENTS[27931] = Fluid3D([15284,15333,14914,14216],0); -ELEMENTS[27932] = Fluid3D([15426,15284,14914,15801],0); -ELEMENTS[27933] = Fluid3D([15426,15933,15939,15801],0); -ELEMENTS[27934] = Fluid3D([15939,15333,15284,15611],0); -ELEMENTS[27935] = Fluid3D([15939,15539,15333,15807],0); -ELEMENTS[27936] = Fluid3D([15939,15539,15807,16305],0); -ELEMENTS[27937] = Fluid3D([15807,15939,16305,16097],0); -ELEMENTS[27938] = Fluid3D([15539,15333,15807,15160],0); -ELEMENTS[27939] = Fluid3D([15539,15333,15160,14796],0); -ELEMENTS[27940] = Fluid3D([15807,15539,15160,15682],0); -ELEMENTS[27941] = Fluid3D([15807,15539,15682,16089],0); -ELEMENTS[27942] = Fluid3D([15539,15160,15682,14956],0); -ELEMENTS[27943] = Fluid3D([15333,15939,15807,15611],0); -ELEMENTS[27944] = Fluid3D([15539,15682,16089,15490],0); -ELEMENTS[27945] = Fluid3D([15682,16089,15490,15946],0); -ELEMENTS[27946] = Fluid3D([15682,16089,15946,16408],0); -ELEMENTS[27947] = Fluid3D([15490,15682,15946,15223],0); -ELEMENTS[27948] = Fluid3D([15682,16089,16408,15807],0); -ELEMENTS[27949] = Fluid3D([15160,15807,15682,15184],0); -ELEMENTS[27950] = Fluid3D([15682,15160,15184,14956],0); -ELEMENTS[27951] = Fluid3D([15160,15807,15184,14770],0); -ELEMENTS[27952] = Fluid3D([15184,15160,14770,14389],0); -ELEMENTS[27953] = Fluid3D([15184,15160,14389,14956],0); -ELEMENTS[27954] = Fluid3D([15333,15807,15160,14770],0); -ELEMENTS[27955] = Fluid3D([15539,15426,15333,14796],0); -ELEMENTS[27956] = Fluid3D([14648,14902,14679,14210],0); -ELEMENTS[27957] = Fluid3D([14679,14648,14210,14111],0); -ELEMENTS[27958] = Fluid3D([16305,16608,16725,16266],0); -ELEMENTS[27959] = Fluid3D([16264,16066,15657,16268],0); -ELEMENTS[27960] = Fluid3D([16827,16656,17075,16951],0); -ELEMENTS[27961] = Fluid3D([16827,16656,16951,16486],0); -ELEMENTS[27962] = Fluid3D([16656,17075,16951,16975],0); -ELEMENTS[27963] = Fluid3D([17075,16827,16951,17274],0); -ELEMENTS[27964] = Fluid3D([16827,16951,17274,17013],0); -ELEMENTS[27965] = Fluid3D([16951,17274,17013,17314],0); -ELEMENTS[27966] = Fluid3D([17013,16951,17314,16915],0); -ELEMENTS[27967] = Fluid3D([16951,17075,17274,17314],0); -ELEMENTS[27968] = Fluid3D([17075,16827,17274,17302],0); -ELEMENTS[27969] = Fluid3D([15850,16264,15928,16189],0); -ELEMENTS[27970] = Fluid3D([15850,16264,16189,16364],0); -ELEMENTS[27971] = Fluid3D([16189,15850,16364,15892],0); -ELEMENTS[27972] = Fluid3D([16364,16533,16748,16799],0); -ELEMENTS[27973] = Fluid3D([17075,16656,16932,16975],0); -ELEMENTS[27974] = Fluid3D([16408,16725,16555,16299],0); -ELEMENTS[27975] = Fluid3D([16408,16725,16299,16305],0); -ELEMENTS[27976] = Fluid3D([16725,16555,16299,16997],0); -ELEMENTS[27977] = Fluid3D([16555,16408,16299,15892],0); -ELEMENTS[27978] = Fluid3D([7042,6914,7678,7427],0); -ELEMENTS[27979] = Fluid3D([14374,13684,13882,14085],0); -ELEMENTS[27980] = Fluid3D([14374,13684,14085,14358],0); -ELEMENTS[27981] = Fluid3D([13684,14085,14358,13776],0); -ELEMENTS[27982] = Fluid3D([15514,15522,15826,15907],0); -ELEMENTS[27983] = Fluid3D([15514,15522,15907,15531],0); -ELEMENTS[27984] = Fluid3D([15907,15514,15531,15947],0); -ELEMENTS[27985] = Fluid3D([15826,15514,15907,16018],0); -ELEMENTS[27986] = Fluid3D([12871,13648,13589,13805],0); -ELEMENTS[27987] = Fluid3D([5157,4854,5026,4593],0); -ELEMENTS[27988] = Fluid3D([3819,4314,4121,3883],0); -ELEMENTS[27989] = Fluid3D([15679,15082,15511,15814],0); -ELEMENTS[27990] = Fluid3D([13256,12831,13440,13850],0); -ELEMENTS[27991] = Fluid3D([7215,8029,7754,8318],0); -ELEMENTS[27992] = Fluid3D([6583,7184,6946,6405],0); -ELEMENTS[27993] = Fluid3D([6583,7184,6405,6590],0); -ELEMENTS[27994] = Fluid3D([7184,6405,6590,7069],0); -ELEMENTS[27995] = Fluid3D([6405,6583,6590,5809],0); -ELEMENTS[27996] = Fluid3D([6583,7184,6590,7185],0); -ELEMENTS[27997] = Fluid3D([6590,6405,5809,5898],0); -ELEMENTS[27998] = Fluid3D([7184,6946,6405,7450],0); -ELEMENTS[27999] = Fluid3D([6946,6583,6405,6188],0); -ELEMENTS[28000] = Fluid3D([7184,6590,7185,7493],0); -ELEMENTS[28001] = Fluid3D([7184,6590,7493,7069],0); -ELEMENTS[28002] = Fluid3D([15277,15159,14799,15570],0); -ELEMENTS[28003] = Fluid3D([10365,11108,10184,10714],0); -ELEMENTS[28004] = Fluid3D([17594,17802,17951,17786],0); -ELEMENTS[28005] = Fluid3D([13588,14289,14133,14138],0); -ELEMENTS[28006] = Fluid3D([13588,14289,14138,14023],0); -ELEMENTS[28007] = Fluid3D([9649,9776,9368,8608],0); -ELEMENTS[28008] = Fluid3D([14818,15300,15465,14758],0); -ELEMENTS[28009] = Fluid3D([13496,12972,12729,13204],0); -ELEMENTS[28010] = Fluid3D([13496,12972,13204,13846],0); -ELEMENTS[28011] = Fluid3D([10373,9680,9463,10098],0); -ELEMENTS[28012] = Fluid3D([18350,18160,18239,18292],0); -ELEMENTS[28013] = Fluid3D([18160,18239,18292,18055],0); -ELEMENTS[28014] = Fluid3D([18350,18160,18292,18340],0); -ELEMENTS[28015] = Fluid3D([18239,18350,18292,18421],0); -ELEMENTS[28016] = Fluid3D([18239,18292,18055,18268],0); -ELEMENTS[28017] = Fluid3D([18055,18239,18268,18047],0); -ELEMENTS[28018] = Fluid3D([18055,18239,18047,17848],0); -ELEMENTS[28019] = Fluid3D([18047,18055,17848,17773],0); -ELEMENTS[28020] = Fluid3D([18292,18239,18421,18268],0); -ELEMENTS[28021] = Fluid3D([18268,18055,18047,17993],0); -ELEMENTS[28022] = Fluid3D([18239,18350,18421,18378],0); -ELEMENTS[28023] = Fluid3D([18160,18239,18055,17848],0); -ELEMENTS[28024] = Fluid3D([18239,18268,18047,18310],0); -ELEMENTS[28025] = Fluid3D([18239,18268,18310,18421],0); -ELEMENTS[28026] = Fluid3D([18268,18047,18310,18205],0); -ELEMENTS[28027] = Fluid3D([18268,18047,18205,18054],0); -ELEMENTS[28028] = Fluid3D([18047,18310,18205,18139],0); -ELEMENTS[28029] = Fluid3D([18047,18239,18310,18122],0); -ELEMENTS[28030] = Fluid3D([18047,18239,18122,17848],0); -ELEMENTS[28031] = Fluid3D([18239,18310,18122,18378],0); -ELEMENTS[28032] = Fluid3D([18122,18047,17848,17967],0); -ELEMENTS[28033] = Fluid3D([18310,18047,18122,18139],0); -ELEMENTS[28034] = Fluid3D([18122,18239,18378,18219],0); -ELEMENTS[28035] = Fluid3D([18122,18239,18219,18160],0); -ELEMENTS[28036] = Fluid3D([18122,18047,17967,18139],0); -ELEMENTS[28037] = Fluid3D([18047,17848,17967,17851],0); -ELEMENTS[28038] = Fluid3D([18047,17848,17851,17773],0); -ELEMENTS[28039] = Fluid3D([17848,17851,17773,17499],0); -ELEMENTS[28040] = Fluid3D([18047,18205,18054,17938],0); -ELEMENTS[28041] = Fluid3D([18205,18054,17938,18099],0); -ELEMENTS[28042] = Fluid3D([18239,18122,17848,18160],0); -ELEMENTS[28043] = Fluid3D([17851,18047,17773,17938],0); -ELEMENTS[28044] = Fluid3D([17773,17851,17938,17575],0); -ELEMENTS[28045] = Fluid3D([17851,18047,17938,18139],0); -ELEMENTS[28046] = Fluid3D([17851,17938,17575,17856],0); -ELEMENTS[28047] = Fluid3D([17851,17938,17856,18139],0); -ELEMENTS[28048] = Fluid3D([17575,17851,17856,17578],0); -ELEMENTS[28049] = Fluid3D([17851,17856,17578,17749],0); -ELEMENTS[28050] = Fluid3D([17575,17851,17578,17499],0); -ELEMENTS[28051] = Fluid3D([18047,17773,17938,18054],0); -ELEMENTS[28052] = Fluid3D([17773,17938,18054,18099],0); -ELEMENTS[28053] = Fluid3D([18047,17773,18054,17993],0); -ELEMENTS[28054] = Fluid3D([17773,18054,17993,17806],0); -ELEMENTS[28055] = Fluid3D([18054,17993,17806,18099],0); -ELEMENTS[28056] = Fluid3D([17773,18054,17806,18099],0); -ELEMENTS[28057] = Fluid3D([17856,17851,18139,17967],0); -ELEMENTS[28058] = Fluid3D([17856,17851,17967,17749],0); -ELEMENTS[28059] = Fluid3D([18139,17856,17967,18048],0); -ELEMENTS[28060] = Fluid3D([18310,18205,18139,18348],0); -ELEMENTS[28061] = Fluid3D([18139,18310,18348,18344],0); -ELEMENTS[28062] = Fluid3D([18205,18139,18348,18158],0); -ELEMENTS[28063] = Fluid3D([18205,18139,18158,17938],0); -ELEMENTS[28064] = Fluid3D([18310,18205,18348,18413],0); -ELEMENTS[28065] = Fluid3D([18310,18205,18413,18268],0); -ELEMENTS[28066] = Fluid3D([18348,18310,18413,18475],0); -ELEMENTS[28067] = Fluid3D([18413,18348,18475,18521],0); -ELEMENTS[28068] = Fluid3D([18348,18310,18475,18344],0); -ELEMENTS[28069] = Fluid3D([18205,18348,18413,18355],0); -ELEMENTS[28070] = Fluid3D([18348,18413,18355,18521],0); -ELEMENTS[28071] = Fluid3D([18205,18348,18355,18158],0); -ELEMENTS[28072] = Fluid3D([18413,18205,18355,18324],0); -ELEMENTS[28073] = Fluid3D([18205,18355,18324,18153],0); -ELEMENTS[28074] = Fluid3D([18324,18205,18153,18099],0); -ELEMENTS[28075] = Fluid3D([18153,18324,18099,18220],0); -ELEMENTS[28076] = Fluid3D([18099,18153,18220,18057],0); -ELEMENTS[28077] = Fluid3D([18099,18153,18057,17821],0); -ELEMENTS[28078] = Fluid3D([18099,18153,17821,17938],0); -ELEMENTS[28079] = Fluid3D([18153,18220,18057,18295],0); -ELEMENTS[28080] = Fluid3D([18153,18220,18295,18355],0); -ELEMENTS[28081] = Fluid3D([18057,18153,18295,18078],0); -ELEMENTS[28082] = Fluid3D([18057,18153,18078,17821],0); -ELEMENTS[28083] = Fluid3D([18295,18153,18355,18158],0); -ELEMENTS[28084] = Fluid3D([18153,18295,18078,18158],0); -ELEMENTS[28085] = Fluid3D([18153,18324,18220,18355],0); -ELEMENTS[28086] = Fluid3D([18413,18205,18324,18268],0); -ELEMENTS[28087] = Fluid3D([18295,18057,18078,18146],0); -ELEMENTS[28088] = Fluid3D([18057,18078,18146,17946],0); -ELEMENTS[28089] = Fluid3D([18146,18057,17946,18075],0); -ELEMENTS[28090] = Fluid3D([17946,18146,18075,18175],0); -ELEMENTS[28091] = Fluid3D([18078,18146,17946,17972],0); -ELEMENTS[28092] = Fluid3D([18146,17946,17972,18175],0); -ELEMENTS[28093] = Fluid3D([18057,17946,18075,17868],0); -ELEMENTS[28094] = Fluid3D([17946,18075,17868,17863],0); -ELEMENTS[28095] = Fluid3D([18075,18057,17868,17952],0); -ELEMENTS[28096] = Fluid3D([18146,18057,18075,18295],0); -ELEMENTS[28097] = Fluid3D([18078,18146,17972,18214],0); -ELEMENTS[28098] = Fluid3D([18146,17972,18214,18175],0); -ELEMENTS[28099] = Fluid3D([18078,18295,18146,18373],0); -ELEMENTS[28100] = Fluid3D([18214,18146,18175,18341],0); -ELEMENTS[28101] = Fluid3D([18214,18146,18341,18373],0); -ELEMENTS[28102] = Fluid3D([18355,18413,18324,18486],0); -ELEMENTS[28103] = Fluid3D([18355,18413,18486,18497],0); -ELEMENTS[28104] = Fluid3D([18413,18324,18486,18458],0); -ELEMENTS[28105] = Fluid3D([18413,18324,18458,18268],0); -ELEMENTS[28106] = Fluid3D([18486,18413,18458,18550],0); -ELEMENTS[28107] = Fluid3D([18413,18458,18550,18421],0); -ELEMENTS[28108] = Fluid3D([18486,18413,18550,18582],0); -ELEMENTS[28109] = Fluid3D([18550,18486,18582,18576],0); -ELEMENTS[28110] = Fluid3D([18205,18355,18153,18158],0); -ELEMENTS[28111] = Fluid3D([18324,18486,18458,18438],0); -ELEMENTS[28112] = Fluid3D([18324,18486,18438,18220],0); -ELEMENTS[28113] = Fluid3D([18486,18458,18438,18576],0); -ELEMENTS[28114] = Fluid3D([18458,18324,18438,18222],0); -ELEMENTS[28115] = Fluid3D([18047,18205,17938,18139],0); -ELEMENTS[28116] = Fluid3D([18268,18047,18054,17993],0); -ELEMENTS[28117] = Fluid3D([18139,18310,18344,18215],0); -ELEMENTS[28118] = Fluid3D([18344,18139,18215,18048],0); -ELEMENTS[28119] = Fluid3D([18310,18344,18215,18412],0); -ELEMENTS[28120] = Fluid3D([18344,18215,18412,18370],0); -ELEMENTS[28121] = Fluid3D([18344,18215,18370,18048],0); -ELEMENTS[28122] = Fluid3D([18412,18344,18370,18543],0); -ELEMENTS[28123] = Fluid3D([18215,18412,18370,18206],0); -ELEMENTS[28124] = Fluid3D([18310,18344,18412,18475],0); -ELEMENTS[28125] = Fluid3D([18344,18412,18475,18543],0); -ELEMENTS[28126] = Fluid3D([18139,18348,18158,18237],0); -ELEMENTS[28127] = Fluid3D([18348,18158,18237,18409],0); -ELEMENTS[28128] = Fluid3D([18139,18348,18237,18344],0); -ELEMENTS[28129] = Fluid3D([18158,18139,18237,18015],0); -ELEMENTS[28130] = Fluid3D([18458,18486,18550,18576],0); -ELEMENTS[28131] = Fluid3D([18350,18292,18421,18435],0); -ELEMENTS[28132] = Fluid3D([18310,18413,18475,18421],0); -ELEMENTS[28133] = Fluid3D([18205,18268,18054,18324],0); -ELEMENTS[28134] = Fluid3D([18292,18160,18055,18039],0); -ELEMENTS[28135] = Fluid3D([18324,18355,18486,18220],0); -ELEMENTS[28136] = Fluid3D([18292,18055,18268,18182],0); -ELEMENTS[28137] = Fluid3D([18292,18055,18182,18039],0); -ELEMENTS[28138] = Fluid3D([18055,18182,18039,17993],0); -ELEMENTS[28139] = Fluid3D([18182,18039,17993,18010],0); -ELEMENTS[28140] = Fluid3D([18182,18039,18010,18255],0); -ELEMENTS[28141] = Fluid3D([18055,18268,18182,17993],0); -ELEMENTS[28142] = Fluid3D([18268,18292,18182,18398],0); -ELEMENTS[28143] = Fluid3D([18292,18182,18398,18404],0); -ELEMENTS[28144] = Fluid3D([18268,18292,18398,18421],0); -ELEMENTS[28145] = Fluid3D([18182,18268,18398,18324],0); -ELEMENTS[28146] = Fluid3D([18182,18292,18039,18300],0); -ELEMENTS[28147] = Fluid3D([8699,9434,9091,8575],0); -ELEMENTS[28148] = Fluid3D([16337,15803,16193,15669],0); -ELEMENTS[28149] = Fluid3D([16337,15803,15669,15897],0); -ELEMENTS[28150] = Fluid3D([15803,15669,15897,15277],0); -ELEMENTS[28151] = Fluid3D([15803,16193,15669,15346],0); -ELEMENTS[28152] = Fluid3D([4624,4807,4450,5165],0); -ELEMENTS[28153] = Fluid3D([4573,4380,4851,4291],0); -ELEMENTS[28154] = Fluid3D([15611,15252,15718,14801],0); -ELEMENTS[28155] = Fluid3D([17372,17086,17223,17503],0); -ELEMENTS[28156] = Fluid3D([17086,17223,17503,17276],0); -ELEMENTS[28157] = Fluid3D([17223,17372,17503,17597],0); -ELEMENTS[28158] = Fluid3D([17372,17086,17503,17384],0); -ELEMENTS[28159] = Fluid3D([16009,16222,16304,16594],0); -ELEMENTS[28160] = Fluid3D([12570,13090,12256,12617],0); -ELEMENTS[28161] = Fluid3D([12570,13090,12617,13409],0); -ELEMENTS[28162] = Fluid3D([13090,12256,12617,12557],0); -ELEMENTS[28163] = Fluid3D([13090,12256,12557,12582],0); -ELEMENTS[28164] = Fluid3D([12256,12570,12617,11289],0); -ELEMENTS[28165] = Fluid3D([4723,4879,5295,5018],0); -ELEMENTS[28166] = Fluid3D([5295,4723,5018,5524],0); -ELEMENTS[28167] = Fluid3D([3111,3116,2783,2987],0); -ELEMENTS[28168] = Fluid3D([16122,16583,16280,16445],0); -ELEMENTS[28169] = Fluid3D([10363,11051,11197,11316],0); -ELEMENTS[28170] = Fluid3D([11051,11197,11316,11890],0); -ELEMENTS[28171] = Fluid3D([10590,9993,9893,9801],0); -ELEMENTS[28172] = Fluid3D([9893,10590,9801,10323],0); -ELEMENTS[28173] = Fluid3D([9801,9893,10323,9555],0); -ELEMENTS[28174] = Fluid3D([10590,9801,10323,10641],0); -ELEMENTS[28175] = Fluid3D([10323,9801,9555,10641],0); -ELEMENTS[28176] = Fluid3D([9555,10323,10641,10192],0); -ELEMENTS[28177] = Fluid3D([10323,10641,10192,10994],0); -ELEMENTS[28178] = Fluid3D([9801,9893,9555,9117],0); -ELEMENTS[28179] = Fluid3D([9801,9893,9117,9185],0); -ELEMENTS[28180] = Fluid3D([9801,9893,9185,9993],0); -ELEMENTS[28181] = Fluid3D([9893,9117,9185,9061],0); -ELEMENTS[28182] = Fluid3D([9893,9185,9993,9468],0); -ELEMENTS[28183] = Fluid3D([9893,9185,9468,9061],0); -ELEMENTS[28184] = Fluid3D([9185,9993,9468,8851],0); -ELEMENTS[28185] = Fluid3D([9893,9555,9117,9766],0); -ELEMENTS[28186] = Fluid3D([9117,9893,9766,9061],0); -ELEMENTS[28187] = Fluid3D([9893,10590,10323,10994],0); -ELEMENTS[28188] = Fluid3D([9993,9893,9468,10594],0); -ELEMENTS[28189] = Fluid3D([9555,9117,9766,9236],0); -ELEMENTS[28190] = Fluid3D([9117,9766,9236,9120],0); -ELEMENTS[28191] = Fluid3D([9766,9236,9120,10221],0); -ELEMENTS[28192] = Fluid3D([9766,9236,10221,10155],0); -ELEMENTS[28193] = Fluid3D([9766,9236,10155,9555],0); -ELEMENTS[28194] = Fluid3D([10221,9766,10155,10994],0); -ELEMENTS[28195] = Fluid3D([9766,10155,10994,10323],0); -ELEMENTS[28196] = Fluid3D([10155,10994,10323,10192],0); -ELEMENTS[28197] = Fluid3D([10323,10155,10192,9555],0); -ELEMENTS[28198] = Fluid3D([10221,9766,10994,10419],0); -ELEMENTS[28199] = Fluid3D([10994,9766,10323,9893],0); -ELEMENTS[28200] = Fluid3D([10155,10994,10192,11172],0); -ELEMENTS[28201] = Fluid3D([10192,10155,11172,10468],0); -ELEMENTS[28202] = Fluid3D([10192,10155,10468,9686],0); -ELEMENTS[28203] = Fluid3D([10192,10155,9686,9555],0); -ELEMENTS[28204] = Fluid3D([9117,9766,9120,9061],0); -ELEMENTS[28205] = Fluid3D([10323,10155,9555,9766],0); -ELEMENTS[28206] = Fluid3D([10221,9766,10419,9629],0); -ELEMENTS[28207] = Fluid3D([10155,10221,10994,11172],0); -ELEMENTS[28208] = Fluid3D([9766,10994,10419,9893],0); -ELEMENTS[28209] = Fluid3D([10155,10468,9686,10497],0); -ELEMENTS[28210] = Fluid3D([10468,9686,10497,9884],0); -ELEMENTS[28211] = Fluid3D([9893,10323,9555,9766],0); -ELEMENTS[28212] = Fluid3D([10323,10641,10994,11167],0); -ELEMENTS[28213] = Fluid3D([10323,10641,11167,10590],0); -ELEMENTS[28214] = Fluid3D([10497,10468,9884,10517],0); -ELEMENTS[28215] = Fluid3D([5954,5450,5947,5667],0); -ELEMENTS[28216] = Fluid3D([5947,5954,5667,6220],0); -ELEMENTS[28217] = Fluid3D([5954,5667,6220,5885],0); -ELEMENTS[28218] = Fluid3D([5450,5947,5667,5650],0); -ELEMENTS[28219] = Fluid3D([5947,5667,5650,6093],0); -ELEMENTS[28220] = Fluid3D([5947,5667,6093,6220],0); -ELEMENTS[28221] = Fluid3D([5650,5947,6093,5841],0); -ELEMENTS[28222] = Fluid3D([5650,5947,5841,5498],0); -ELEMENTS[28223] = Fluid3D([5947,6093,5841,6504],0); -ELEMENTS[28224] = Fluid3D([5947,6093,6504,6802],0); -ELEMENTS[28225] = Fluid3D([5667,5650,6093,5642],0); -ELEMENTS[28226] = Fluid3D([6093,5667,5642,6220],0); -ELEMENTS[28227] = Fluid3D([5841,5947,6504,6164],0); -ELEMENTS[28228] = Fluid3D([5667,5650,5642,5146],0); -ELEMENTS[28229] = Fluid3D([6093,5841,6504,6294],0); -ELEMENTS[28230] = Fluid3D([6504,6093,6294,6802],0); -ELEMENTS[28231] = Fluid3D([5450,5947,5650,5498],0); -ELEMENTS[28232] = Fluid3D([6093,5841,6294,5439],0); -ELEMENTS[28233] = Fluid3D([6093,5650,5841,5439],0); -ELEMENTS[28234] = Fluid3D([5841,6504,6294,6396],0); -ELEMENTS[28235] = Fluid3D([6504,6294,6396,7126],0); -ELEMENTS[28236] = Fluid3D([5841,6504,6396,6164],0); -ELEMENTS[28237] = Fluid3D([5954,5450,5667,5885],0); -ELEMENTS[28238] = Fluid3D([6294,5841,6396,5881],0); -ELEMENTS[28239] = Fluid3D([6396,6294,5881,6450],0); -ELEMENTS[28240] = Fluid3D([5881,6396,6450,6244],0); -ELEMENTS[28241] = Fluid3D([6450,5881,6244,6123],0); -ELEMENTS[28242] = Fluid3D([5650,6093,5642,5758],0); -ELEMENTS[28243] = Fluid3D([5881,6396,6244,5917],0); -ELEMENTS[28244] = Fluid3D([5881,6396,5917,5841],0); -ELEMENTS[28245] = Fluid3D([6396,5917,5841,6164],0); -ELEMENTS[28246] = Fluid3D([6396,6244,5917,6646],0); -ELEMENTS[28247] = Fluid3D([6396,6244,6646,6450],0); -ELEMENTS[28248] = Fluid3D([6294,5841,5881,5773],0); -ELEMENTS[28249] = Fluid3D([6396,6294,6450,7126],0); -ELEMENTS[28250] = Fluid3D([6294,5881,6450,5773],0); -ELEMENTS[28251] = Fluid3D([4923,4693,4798,5229],0); -ELEMENTS[28252] = Fluid3D([7541,8210,7403,7621],0); -ELEMENTS[28253] = Fluid3D([14670,13971,13855,14322],0); -ELEMENTS[28254] = Fluid3D([3417,3671,3158,3214],0); -ELEMENTS[28255] = Fluid3D([10876,10391,9902,10171],0); -ELEMENTS[28256] = Fluid3D([10391,9902,10171,9607],0); -ELEMENTS[28257] = Fluid3D([9902,10876,10171,10070],0); -ELEMENTS[28258] = Fluid3D([10171,9902,10070,9607],0); -ELEMENTS[28259] = Fluid3D([10876,10391,10171,11072],0); -ELEMENTS[28260] = Fluid3D([9902,10876,10070,10606],0); -ELEMENTS[28261] = Fluid3D([10876,10171,10070,10853],0); -ELEMENTS[28262] = Fluid3D([10171,10070,10853,10097],0); -ELEMENTS[28263] = Fluid3D([10070,10853,10097,10459],0); -ELEMENTS[28264] = Fluid3D([10853,10097,10459,10424],0); -ELEMENTS[28265] = Fluid3D([10097,10070,10459,9678],0); -ELEMENTS[28266] = Fluid3D([10876,10171,10853,11072],0); -ELEMENTS[28267] = Fluid3D([10853,10171,10097,10597],0); -ELEMENTS[28268] = Fluid3D([10070,10876,10853,11185],0); -ELEMENTS[28269] = Fluid3D([10876,10853,11185,11886],0); -ELEMENTS[28270] = Fluid3D([10853,10070,11185,10459],0); -ELEMENTS[28271] = Fluid3D([10070,10876,11185,10606],0); -ELEMENTS[28272] = Fluid3D([11185,10070,10606,10459],0); -ELEMENTS[28273] = Fluid3D([10171,10070,10097,9607],0); -ELEMENTS[28274] = Fluid3D([10097,10171,9607,9992],0); -ELEMENTS[28275] = Fluid3D([9607,10097,9992,9381],0); -ELEMENTS[28276] = Fluid3D([10097,9992,9381,9553],0); -ELEMENTS[28277] = Fluid3D([9607,10097,9381,9621],0); -ELEMENTS[28278] = Fluid3D([10097,9381,9621,9678],0); -ELEMENTS[28279] = Fluid3D([9381,10097,9553,10424],0); -ELEMENTS[28280] = Fluid3D([9607,10097,9621,10070],0); -ELEMENTS[28281] = Fluid3D([10097,9621,10070,9678],0); -ELEMENTS[28282] = Fluid3D([9621,10070,9678,9774],0); -ELEMENTS[28283] = Fluid3D([10097,9992,9553,10424],0); -ELEMENTS[28284] = Fluid3D([9381,10097,10424,10459],0); -ELEMENTS[28285] = Fluid3D([9381,10097,10459,9678],0); -ELEMENTS[28286] = Fluid3D([10171,9607,9992,10426],0); -ELEMENTS[28287] = Fluid3D([10097,10171,9992,10597],0); -ELEMENTS[28288] = Fluid3D([9992,10097,10597,10907],0); -ELEMENTS[28289] = Fluid3D([10597,9992,10907,10302],0); -ELEMENTS[28290] = Fluid3D([9992,10097,10907,10424],0); -ELEMENTS[28291] = Fluid3D([9381,9621,9678,8634],0); -ELEMENTS[28292] = Fluid3D([9621,9607,10070,9902],0); -ELEMENTS[28293] = Fluid3D([10070,9621,9902,9774],0); -ELEMENTS[28294] = Fluid3D([13375,12660,12738,13898],0); -ELEMENTS[28295] = Fluid3D([6618,6047,6638,5806],0); -ELEMENTS[28296] = Fluid3D([4190,4071,4126,3673],0); -ELEMENTS[28297] = Fluid3D([11781,11942,12023,10815],0); -ELEMENTS[28298] = Fluid3D([12943,13720,12977,13161],0); -ELEMENTS[28299] = Fluid3D([10170,9356,9546,10089],0); -ELEMENTS[28300] = Fluid3D([15841,16322,16380,16363],0); -ELEMENTS[28301] = Fluid3D([13085,13585,12689,12468],0); -ELEMENTS[28302] = Fluid3D([13178,12619,12589,12358],0); -ELEMENTS[28303] = Fluid3D([5506,5883,5535,6156],0); -ELEMENTS[28304] = Fluid3D([7147,6947,7707,6960],0); -ELEMENTS[28305] = Fluid3D([6947,7707,6960,7354],0); -ELEMENTS[28306] = Fluid3D([7707,7147,6960,7967],0); -ELEMENTS[28307] = Fluid3D([7147,6947,6960,6251],0); -ELEMENTS[28308] = Fluid3D([5509,6052,6044,6131],0); -ELEMENTS[28309] = Fluid3D([8606,8599,8054,7968],0); -ELEMENTS[28310] = Fluid3D([18399,18535,18520,18518],0); -ELEMENTS[28311] = Fluid3D([5058,4795,4466,4883],0); -ELEMENTS[28312] = Fluid3D([5058,4795,4883,5472],0); -ELEMENTS[28313] = Fluid3D([4795,4466,4883,4343],0); -ELEMENTS[28314] = Fluid3D([4795,4883,5472,5094],0); -ELEMENTS[28315] = Fluid3D([9191,9443,8505,8770],0); -ELEMENTS[28316] = Fluid3D([14529,14194,13749,13760],0); -ELEMENTS[28317] = Fluid3D([16368,16591,16369,15836],0); -ELEMENTS[28318] = Fluid3D([10637,10242,9894,10976],0); -ELEMENTS[28319] = Fluid3D([13135,13288,12413,13081],0); -ELEMENTS[28320] = Fluid3D([12413,13135,13081,12476],0); -ELEMENTS[28321] = Fluid3D([13135,13081,12476,13609],0); -ELEMENTS[28322] = Fluid3D([13135,13288,13081,13957],0); -ELEMENTS[28323] = Fluid3D([12413,13135,12476,12292],0); -ELEMENTS[28324] = Fluid3D([13081,12413,12476,12032],0); -ELEMENTS[28325] = Fluid3D([13288,12413,13081,13037],0); -ELEMENTS[28326] = Fluid3D([8910,8206,8148,8682],0); -ELEMENTS[28327] = Fluid3D([8148,8910,8682,8598],0); -ELEMENTS[28328] = Fluid3D([8682,8148,8598,8367],0); -ELEMENTS[28329] = Fluid3D([8682,8148,8367,8032],0); -ELEMENTS[28330] = Fluid3D([6163,5844,6190,6523],0); -ELEMENTS[28331] = Fluid3D([13140,13153,13261,14003],0); -ELEMENTS[28332] = Fluid3D([12588,12797,13414,12648],0); -ELEMENTS[28333] = Fluid3D([13848,13109,13113,13333],0); -ELEMENTS[28334] = Fluid3D([13113,13848,13333,13612],0); -ELEMENTS[28335] = Fluid3D([13848,13109,13333,13652],0); -ELEMENTS[28336] = Fluid3D([13109,13113,13333,12326],0); -ELEMENTS[28337] = Fluid3D([13109,13113,12326,12711],0); -ELEMENTS[28338] = Fluid3D([13113,13333,12326,12761],0); -ELEMENTS[28339] = Fluid3D([13113,13333,12761,13612],0); -ELEMENTS[28340] = Fluid3D([12326,13113,12761,12348],0); -ELEMENTS[28341] = Fluid3D([13333,12326,12761,12344],0); -ELEMENTS[28342] = Fluid3D([12761,13333,12344,12484],0); -ELEMENTS[28343] = Fluid3D([13333,12326,12344,12673],0); -ELEMENTS[28344] = Fluid3D([12326,12761,12344,11609],0); -ELEMENTS[28345] = Fluid3D([12344,12326,11609,11832],0); -ELEMENTS[28346] = Fluid3D([12326,11609,11832,11604],0); -ELEMENTS[28347] = Fluid3D([11832,12326,11604,12711],0); -ELEMENTS[28348] = Fluid3D([13333,13109,12326,12673],0); -ELEMENTS[28349] = Fluid3D([8791,9511,9484,9631],0); -ELEMENTS[28350] = Fluid3D([10872,10908,11443,10269],0); -ELEMENTS[28351] = Fluid3D([4040,4304,4039,3822],0); -ELEMENTS[28352] = Fluid3D([4304,4039,3822,4356],0); -ELEMENTS[28353] = Fluid3D([16590,16946,16960,16581],0); -ELEMENTS[28354] = Fluid3D([16590,16946,16581,16482],0); -ELEMENTS[28355] = Fluid3D([16946,16960,16581,17002],0); -ELEMENTS[28356] = Fluid3D([16581,16946,17002,16755],0); -ELEMENTS[28357] = Fluid3D([16946,17002,16755,17254],0); -ELEMENTS[28358] = Fluid3D([16946,17002,17254,17352],0); -ELEMENTS[28359] = Fluid3D([16946,17002,17352,16960],0); -ELEMENTS[28360] = Fluid3D([16960,16590,16581,16449],0); -ELEMENTS[28361] = Fluid3D([10960,10149,10868,10482],0); -ELEMENTS[28362] = Fluid3D([10149,10868,10482,10284],0); -ELEMENTS[28363] = Fluid3D([11121,10887,11769,10711],0); -ELEMENTS[28364] = Fluid3D([9741,10576,9914,10449],0); -ELEMENTS[28365] = Fluid3D([9741,10576,10449,10753],0); -ELEMENTS[28366] = Fluid3D([10449,9741,10753,10014],0); -ELEMENTS[28367] = Fluid3D([9773,8891,9690,9293],0); -ELEMENTS[28368] = Fluid3D([7073,6259,6736,6868],0); -ELEMENTS[28369] = Fluid3D([6050,5415,6000,5843],0); -ELEMENTS[28370] = Fluid3D([6050,5415,5843,5945],0); -ELEMENTS[28371] = Fluid3D([5415,6000,5843,5165],0); -ELEMENTS[28372] = Fluid3D([6000,6050,5843,7078],0); -ELEMENTS[28373] = Fluid3D([3057,3334,3501,3583],0); -ELEMENTS[28374] = Fluid3D([16057,15434,15794,15629],0); -ELEMENTS[28375] = Fluid3D([12483,12613,11768,11861],0); -ELEMENTS[28376] = Fluid3D([8659,8962,7895,9080],0); -ELEMENTS[28377] = Fluid3D([17855,17691,17560,17789],0); -ELEMENTS[28378] = Fluid3D([17691,17560,17789,17444],0); -ELEMENTS[28379] = Fluid3D([17855,17691,17789,17900],0); -ELEMENTS[28380] = Fluid3D([17691,17789,17900,17678],0); -ELEMENTS[28381] = Fluid3D([17560,17855,17789,17805],0); -ELEMENTS[28382] = Fluid3D([17789,17900,17678,17961],0); -ELEMENTS[28383] = Fluid3D([17691,17789,17678,17444],0); -ELEMENTS[28384] = Fluid3D([17560,17789,17444,17799],0); -ELEMENTS[28385] = Fluid3D([17691,17560,17444,17297],0); -ELEMENTS[28386] = Fluid3D([17855,17691,17900,17971],0); -ELEMENTS[28387] = Fluid3D([17900,17691,17678,17971],0); -ELEMENTS[28388] = Fluid3D([17678,17900,17971,17961],0); -ELEMENTS[28389] = Fluid3D([17789,17855,17900,18093],0); -ELEMENTS[28390] = Fluid3D([17855,17900,18093,18110],0); -ELEMENTS[28391] = Fluid3D([17855,17900,18110,17971],0); -ELEMENTS[28392] = Fluid3D([18093,17855,18110,18154],0); -ELEMENTS[28393] = Fluid3D([17900,18093,18110,17961],0); -ELEMENTS[28394] = Fluid3D([17855,18110,18154,18065],0); -ELEMENTS[28395] = Fluid3D([18110,18093,18154,18321],0); -ELEMENTS[28396] = Fluid3D([17855,18110,18065,17858],0); -ELEMENTS[28397] = Fluid3D([18110,18093,18321,18201],0); -ELEMENTS[28398] = Fluid3D([18110,18093,18201,17961],0); -ELEMENTS[28399] = Fluid3D([17900,18110,17971,17961],0); -ELEMENTS[28400] = Fluid3D([18110,18154,18065,18308],0); -ELEMENTS[28401] = Fluid3D([18154,18110,18321,18308],0); -ELEMENTS[28402] = Fluid3D([18110,18321,18308,18327],0); -ELEMENTS[28403] = Fluid3D([18321,18308,18327,18471],0); -ELEMENTS[28404] = Fluid3D([18321,18110,18201,18327],0); -ELEMENTS[28405] = Fluid3D([18065,18110,18308,18171],0); -ELEMENTS[28406] = Fluid3D([18065,18110,18171,17858],0); -ELEMENTS[28407] = Fluid3D([18321,18154,18308,18377],0); -ELEMENTS[28408] = Fluid3D([18308,18321,18377,18471],0); -ELEMENTS[28409] = Fluid3D([18093,18321,18201,18342],0); -ELEMENTS[28410] = Fluid3D([18110,18201,18327,18263],0); -ELEMENTS[28411] = Fluid3D([18201,18327,18263,18455],0); -ELEMENTS[28412] = Fluid3D([18377,18308,18471,18361],0); -ELEMENTS[28413] = Fluid3D([18377,18308,18361,18154],0); -ELEMENTS[28414] = Fluid3D([18308,18471,18361,18358],0); -ELEMENTS[28415] = Fluid3D([18361,18308,18358,18221],0); -ELEMENTS[28416] = Fluid3D([18308,18471,18358,18327],0); -ELEMENTS[28417] = Fluid3D([18358,18308,18327,18171],0); -ELEMENTS[28418] = Fluid3D([18358,18308,18171,18221],0); -ELEMENTS[28419] = Fluid3D([18171,18358,18221,18323],0); -ELEMENTS[28420] = Fluid3D([18327,18358,18171,18323],0); -ELEMENTS[28421] = Fluid3D([18154,17855,18065,17947],0); -ELEMENTS[28422] = Fluid3D([18093,18154,18321,18257],0); -ELEMENTS[28423] = Fluid3D([18308,18110,18327,18171],0); -ELEMENTS[28424] = Fluid3D([17855,18065,17947,17896],0); -ELEMENTS[28425] = Fluid3D([18065,17947,17896,18137],0); -ELEMENTS[28426] = Fluid3D([17896,18065,18137,18221],0); -ELEMENTS[28427] = Fluid3D([18321,18093,18257,18342],0); -ELEMENTS[28428] = Fluid3D([18093,17855,18154,17965],0); -ELEMENTS[28429] = Fluid3D([18093,18154,18257,17965],0); -ELEMENTS[28430] = Fluid3D([17855,18154,17965,17947],0); -ELEMENTS[28431] = Fluid3D([18110,18327,18171,18263],0); -ELEMENTS[28432] = Fluid3D([18201,18321,18327,18461],0); -ELEMENTS[28433] = Fluid3D([18065,17947,18137,18154],0); -ELEMENTS[28434] = Fluid3D([17855,18110,17858,17971],0); -ELEMENTS[28435] = Fluid3D([18308,18065,18171,18221],0); -ELEMENTS[28436] = Fluid3D([18065,18171,18221,17970],0); -ELEMENTS[28437] = Fluid3D([18171,18221,17970,18142],0); -ELEMENTS[28438] = Fluid3D([18065,18171,17970,17858],0); -ELEMENTS[28439] = Fluid3D([17970,18065,17858,17896],0); -ELEMENTS[28440] = Fluid3D([17970,18065,17896,18221],0); -ELEMENTS[28441] = Fluid3D([18171,17970,17858,18051],0); -ELEMENTS[28442] = Fluid3D([18154,18321,18257,18377],0); -ELEMENTS[28443] = Fluid3D([18093,17855,17965,17789],0); -ELEMENTS[28444] = Fluid3D([18154,18065,18308,18137],0); -ELEMENTS[28445] = Fluid3D([18327,18171,18263,18323],0); -ELEMENTS[28446] = Fluid3D([17900,17789,18093,17961],0); -ELEMENTS[28447] = Fluid3D([17947,17896,18137,17770],0); -ELEMENTS[28448] = Fluid3D([13264,13341,14027,13789],0); -ELEMENTS[28449] = Fluid3D([13341,14027,13789,14323],0); -ELEMENTS[28450] = Fluid3D([13264,13341,13789,13438],0); -ELEMENTS[28451] = Fluid3D([14027,13264,13789,13566],0); -ELEMENTS[28452] = Fluid3D([13264,13789,13566,13438],0); -ELEMENTS[28453] = Fluid3D([5980,6694,6375,6119],0); -ELEMENTS[28454] = Fluid3D([5980,6694,6119,5894],0); -ELEMENTS[28455] = Fluid3D([6119,5980,5894,5549],0); -ELEMENTS[28456] = Fluid3D([5894,6119,5549,5807],0); -ELEMENTS[28457] = Fluid3D([6694,6375,6119,7085],0); -ELEMENTS[28458] = Fluid3D([6375,5980,6119,5697],0); -ELEMENTS[28459] = Fluid3D([5980,6119,5697,5549],0); -ELEMENTS[28460] = Fluid3D([6119,5697,5549,6084],0); -ELEMENTS[28461] = Fluid3D([6119,6375,5697,6084],0); -ELEMENTS[28462] = Fluid3D([6375,5980,5697,5921],0); -ELEMENTS[28463] = Fluid3D([6235,6763,6001,6212],0); -ELEMENTS[28464] = Fluid3D([13382,12755,12998,13494],0); -ELEMENTS[28465] = Fluid3D([3766,3391,3741,3260],0); -ELEMENTS[28466] = Fluid3D([4048,4413,4285,4946],0); -ELEMENTS[28467] = Fluid3D([15138,14812,15020,15571],0); -ELEMENTS[28468] = Fluid3D([15020,15138,15571,15281],0); -ELEMENTS[28469] = Fluid3D([15138,15571,15281,15822],0); -ELEMENTS[28470] = Fluid3D([15138,15571,15822,15526],0); -ELEMENTS[28471] = Fluid3D([15138,14812,15571,15039],0); -ELEMENTS[28472] = Fluid3D([6643,6052,6292,6766],0); -ELEMENTS[28473] = Fluid3D([14403,14154,14873,14185],0); -ELEMENTS[28474] = Fluid3D([14154,14873,14185,14456],0); -ELEMENTS[28475] = Fluid3D([14403,14154,14185,13484],0); -ELEMENTS[28476] = Fluid3D([14873,14185,14456,14850],0); -ELEMENTS[28477] = Fluid3D([14456,14873,14850,15229],0); -ELEMENTS[28478] = Fluid3D([14850,14456,15229,14774],0); -ELEMENTS[28479] = Fluid3D([14850,14456,14774,14141],0); -ELEMENTS[28480] = Fluid3D([14850,14456,14141,14185],0); -ELEMENTS[28481] = Fluid3D([14774,14850,14141,14749],0); -ELEMENTS[28482] = Fluid3D([14774,14850,14749,15381],0); -ELEMENTS[28483] = Fluid3D([14774,14850,15381,15229],0); -ELEMENTS[28484] = Fluid3D([14141,14774,14749,14259],0); -ELEMENTS[28485] = Fluid3D([14141,14774,14259,13992],0); -ELEMENTS[28486] = Fluid3D([14259,14141,13992,13428],0); -ELEMENTS[28487] = Fluid3D([14774,14749,14259,15022],0); -ELEMENTS[28488] = Fluid3D([14873,14403,14185,14722],0); -ELEMENTS[28489] = Fluid3D([14141,14774,13992,14456],0); -ELEMENTS[28490] = Fluid3D([14456,14873,15229,15133],0); -ELEMENTS[28491] = Fluid3D([14873,14185,14850,14722],0); -ELEMENTS[28492] = Fluid3D([14749,14141,14259,14469],0); -ELEMENTS[28493] = Fluid3D([14259,14749,14469,15022],0); -ELEMENTS[28494] = Fluid3D([14749,14774,15381,15022],0); -ELEMENTS[28495] = Fluid3D([14154,14873,14456,15133],0); -ELEMENTS[28496] = Fluid3D([14456,15229,14774,15273],0); -ELEMENTS[28497] = Fluid3D([14850,14141,14749,14195],0); -ELEMENTS[28498] = Fluid3D([14850,14749,15381,15346],0); -ELEMENTS[28499] = Fluid3D([14185,14154,14456,13579],0); -ELEMENTS[28500] = Fluid3D([14185,14154,13579,13484],0); -ELEMENTS[28501] = Fluid3D([14154,14456,13579,13926],0); -ELEMENTS[28502] = Fluid3D([14154,14456,13926,15133],0); -ELEMENTS[28503] = Fluid3D([13579,14154,13926,13153],0); -ELEMENTS[28504] = Fluid3D([14456,14185,13579,14141],0); -ELEMENTS[28505] = Fluid3D([14456,13579,13926,13992],0); -ELEMENTS[28506] = Fluid3D([14873,14850,15229,15345],0); -ELEMENTS[28507] = Fluid3D([14873,14850,15345,14722],0); -ELEMENTS[28508] = Fluid3D([15229,14873,15345,15498],0); -ELEMENTS[28509] = Fluid3D([14873,15345,15498,15208],0); -ELEMENTS[28510] = Fluid3D([14850,15229,15345,15381],0); -ELEMENTS[28511] = Fluid3D([15229,14873,15498,15133],0); -ELEMENTS[28512] = Fluid3D([15345,15229,15498,15779],0); -ELEMENTS[28513] = Fluid3D([15229,15498,15779,15133],0); -ELEMENTS[28514] = Fluid3D([15498,15779,15133,15662],0); -ELEMENTS[28515] = Fluid3D([15498,15779,15662,16244],0); -ELEMENTS[28516] = Fluid3D([15133,15498,15662,14786],0); -ELEMENTS[28517] = Fluid3D([14774,14259,13992,14598],0); -ELEMENTS[28518] = Fluid3D([14774,14259,14598,15022],0); -ELEMENTS[28519] = Fluid3D([14259,13992,14598,13428],0); -ELEMENTS[28520] = Fluid3D([13992,14774,14598,14723],0); -ELEMENTS[28521] = Fluid3D([5458,6094,5674,6134],0); -ELEMENTS[28522] = Fluid3D([11561,11082,10705,10776],0); -ELEMENTS[28523] = Fluid3D([15808,15603,15051,15915],0); -ELEMENTS[28524] = Fluid3D([15808,15603,15915,16277],0); -ELEMENTS[28525] = Fluid3D([15603,15051,15915,15584],0); -ELEMENTS[28526] = Fluid3D([15915,15603,15584,16296],0); -ELEMENTS[28527] = Fluid3D([15603,15051,15584,14937],0); -ELEMENTS[28528] = Fluid3D([15603,15051,14937,15189],0); -ELEMENTS[28529] = Fluid3D([15051,15584,14937,14436],0); -ELEMENTS[28530] = Fluid3D([15051,15915,15584,15598],0); -ELEMENTS[28531] = Fluid3D([15915,15584,15598,15817],0); -ELEMENTS[28532] = Fluid3D([15584,15051,15598,15048],0); -ELEMENTS[28533] = Fluid3D([15598,15584,15048,15427],0); -ELEMENTS[28534] = Fluid3D([15048,15598,15427,14903],0); -ELEMENTS[28535] = Fluid3D([15427,15048,14903,15584],0); -ELEMENTS[28536] = Fluid3D([15051,15915,15598,15592],0); -ELEMENTS[28537] = Fluid3D([15598,15584,15427,15817],0); -ELEMENTS[28538] = Fluid3D([15427,15598,15817,15734],0); -ELEMENTS[28539] = Fluid3D([15584,15427,15817,15512],0); -ELEMENTS[28540] = Fluid3D([15427,15817,15512,15418],0); -ELEMENTS[28541] = Fluid3D([15427,15817,15418,15734],0); -ELEMENTS[28542] = Fluid3D([15512,15427,15418,14810],0); -ELEMENTS[28543] = Fluid3D([15584,15051,15048,14436],0); -ELEMENTS[28544] = Fluid3D([15051,15598,15048,15174],0); -ELEMENTS[28545] = Fluid3D([15598,15048,15174,15187],0); -ELEMENTS[28546] = Fluid3D([15048,15174,15187,14285],0); -ELEMENTS[28547] = Fluid3D([15051,15598,15174,15592],0); -ELEMENTS[28548] = Fluid3D([15048,15051,15174,14414],0); -ELEMENTS[28549] = Fluid3D([15174,15598,15187,15412],0); -ELEMENTS[28550] = Fluid3D([15187,15174,15412,14826],0); -ELEMENTS[28551] = Fluid3D([15174,15412,14826,14414],0); -ELEMENTS[28552] = Fluid3D([15187,15174,14826,14285],0); -ELEMENTS[28553] = Fluid3D([14826,15187,14285,14676],0); -ELEMENTS[28554] = Fluid3D([15174,14826,14285,14414],0); -ELEMENTS[28555] = Fluid3D([14826,14285,14414,14151],0); -ELEMENTS[28556] = Fluid3D([15412,15187,14826,15271],0); -ELEMENTS[28557] = Fluid3D([15187,14826,15271,14676],0); -ELEMENTS[28558] = Fluid3D([15271,15187,14676,15276],0); -ELEMENTS[28559] = Fluid3D([15271,15187,15276,15734],0); -ELEMENTS[28560] = Fluid3D([15276,15271,15734,15335],0); -ELEMENTS[28561] = Fluid3D([15734,15276,15335,15418],0); -ELEMENTS[28562] = Fluid3D([15734,15276,15418,15427],0); -ELEMENTS[28563] = Fluid3D([15276,15418,15427,14903],0); -ELEMENTS[28564] = Fluid3D([15276,15335,15418,14676],0); -ELEMENTS[28565] = Fluid3D([15427,15276,14903,15187],0); -ELEMENTS[28566] = Fluid3D([14903,15427,15187,15598],0); -ELEMENTS[28567] = Fluid3D([15276,14903,15187,14676],0); -ELEMENTS[28568] = Fluid3D([15276,15418,14903,14676],0); -ELEMENTS[28569] = Fluid3D([15271,15187,15734,15699],0); -ELEMENTS[28570] = Fluid3D([15271,15187,15699,15412],0); -ELEMENTS[28571] = Fluid3D([15187,15699,15412,15598],0); -ELEMENTS[28572] = Fluid3D([15699,15271,15412,15299],0); -ELEMENTS[28573] = Fluid3D([15734,15271,15699,16042],0); -ELEMENTS[28574] = Fluid3D([15187,15276,15734,15427],0); -ELEMENTS[28575] = Fluid3D([15699,15412,15598,15958],0); -ELEMENTS[28576] = Fluid3D([15699,15412,15958,15845],0); -ELEMENTS[28577] = Fluid3D([15412,15958,15845,15592],0); -ELEMENTS[28578] = Fluid3D([15958,15845,15592,16237],0); -ELEMENTS[28579] = Fluid3D([15598,15699,15958,16118],0); -ELEMENTS[28580] = Fluid3D([15699,15958,16118,16393],0); -ELEMENTS[28581] = Fluid3D([15598,15699,16118,15734],0); -ELEMENTS[28582] = Fluid3D([15418,15427,14903,14810],0); -ELEMENTS[28583] = Fluid3D([15427,14903,14810,14936],0); -ELEMENTS[28584] = Fluid3D([15427,14903,14936,15584],0); -ELEMENTS[28585] = Fluid3D([15187,15699,15598,15734],0); -ELEMENTS[28586] = Fluid3D([15174,15598,15412,15592],0); -ELEMENTS[28587] = Fluid3D([15412,15174,15592,15261],0); -ELEMENTS[28588] = Fluid3D([15412,15174,15261,14414],0); -ELEMENTS[28589] = Fluid3D([14903,15187,14676,14285],0); -ELEMENTS[28590] = Fluid3D([15412,15699,15299,16042],0); -ELEMENTS[28591] = Fluid3D([15699,16118,15734,16042],0); -ELEMENTS[28592] = Fluid3D([15699,16118,16042,16393],0); -ELEMENTS[28593] = Fluid3D([14826,14285,14151,14373],0); -ELEMENTS[28594] = Fluid3D([15598,15048,15187,14903],0); -ELEMENTS[28595] = Fluid3D([15048,15187,14903,14285],0); -ELEMENTS[28596] = Fluid3D([15051,15808,15915,15592],0); -ELEMENTS[28597] = Fluid3D([15584,15603,14937,15376],0); -ELEMENTS[28598] = Fluid3D([15584,15603,15376,16296],0); -ELEMENTS[28599] = Fluid3D([15603,14937,15376,15182],0); -ELEMENTS[28600] = Fluid3D([14937,15584,15376,14936],0); -ELEMENTS[28601] = Fluid3D([3499,3945,3669,3444],0); -ELEMENTS[28602] = Fluid3D([10678,11169,10255,10674],0); -ELEMENTS[28603] = Fluid3D([10678,11169,10674,10829],0); -ELEMENTS[28604] = Fluid3D([11169,10255,10674,10392],0); -ELEMENTS[28605] = Fluid3D([10674,11169,10392,11378],0); -ELEMENTS[28606] = Fluid3D([6497,6806,7337,7432],0); -ELEMENTS[28607] = Fluid3D([7337,6497,7432,6993],0); -ELEMENTS[28608] = Fluid3D([7754,7446,7443,8257],0); -ELEMENTS[28609] = Fluid3D([15294,15015,15306,14656],0); -ELEMENTS[28610] = Fluid3D([11582,10635,11445,10357],0); -ELEMENTS[28611] = Fluid3D([7844,7450,7818,6946],0); -ELEMENTS[28612] = Fluid3D([9535,10457,10372,10109],0); -ELEMENTS[28613] = Fluid3D([13393,14059,14070,13625],0); -ELEMENTS[28614] = Fluid3D([16901,17310,17229,17214],0); -ELEMENTS[28615] = Fluid3D([16901,17310,17214,16882],0); -ELEMENTS[28616] = Fluid3D([17310,17229,17214,17628],0); -ELEMENTS[28617] = Fluid3D([17229,16901,17214,16910],0); -ELEMENTS[28618] = Fluid3D([16901,17214,16910,16796],0); -ELEMENTS[28619] = Fluid3D([17229,16901,16910,16769],0); -ELEMENTS[28620] = Fluid3D([17214,16910,16796,17037],0); -ELEMENTS[28621] = Fluid3D([16796,17214,17037,17176],0); -ELEMENTS[28622] = Fluid3D([17214,17229,16910,17376],0); -ELEMENTS[28623] = Fluid3D([17037,16796,17176,16770],0); -ELEMENTS[28624] = Fluid3D([16796,17214,17176,16882],0); -ELEMENTS[28625] = Fluid3D([17214,16910,17037,17395],0); -ELEMENTS[28626] = Fluid3D([17037,17214,17395,17176],0); -ELEMENTS[28627] = Fluid3D([17214,17395,17176,17655],0); -ELEMENTS[28628] = Fluid3D([16901,17214,16796,16882],0); -ELEMENTS[28629] = Fluid3D([16910,16901,16796,16164],0); -ELEMENTS[28630] = Fluid3D([16910,16796,17037,16464],0); -ELEMENTS[28631] = Fluid3D([4102,3988,4125,4480],0); -ELEMENTS[28632] = Fluid3D([6467,6459,5788,6035],0); -ELEMENTS[28633] = Fluid3D([12614,11839,11904,13043],0); -ELEMENTS[28634] = Fluid3D([12428,13007,13052,13718],0); -ELEMENTS[28635] = Fluid3D([13302,12576,12734,12080],0); -ELEMENTS[28636] = Fluid3D([10098,9817,10743,9680],0); -ELEMENTS[28637] = Fluid3D([18178,18143,18347,18148],0); -ELEMENTS[28638] = Fluid3D([5581,5192,5494,5979],0); -ELEMENTS[28639] = Fluid3D([5494,5581,5979,6132],0); -ELEMENTS[28640] = Fluid3D([5581,5979,6132,6203],0); -ELEMENTS[28641] = Fluid3D([11944,11240,11280,12195],0); -ELEMENTS[28642] = Fluid3D([17804,17835,17451,17919],0); -ELEMENTS[28643] = Fluid3D([16734,16493,17006,16758],0); -ELEMENTS[28644] = Fluid3D([16734,16493,16758,16218],0); -ELEMENTS[28645] = Fluid3D([16493,17006,16758,16649],0); -ELEMENTS[28646] = Fluid3D([17006,16734,16758,16959],0); -ELEMENTS[28647] = Fluid3D([8219,8406,8365,7488],0); -ELEMENTS[28648] = Fluid3D([14965,14979,14701,14361],0); -ELEMENTS[28649] = Fluid3D([15055,15099,14569,14322],0); -ELEMENTS[28650] = Fluid3D([13925,13937,13334,14264],0); -ELEMENTS[28651] = Fluid3D([3125,2899,2854,2841],0); -ELEMENTS[28652] = Fluid3D([2793,2953,3022,2770],0); -ELEMENTS[28653] = Fluid3D([17046,16713,16967,16650],0); -ELEMENTS[28654] = Fluid3D([11710,11748,11986,12644],0); -ELEMENTS[28655] = Fluid3D([7109,7942,7712,7908],0); -ELEMENTS[28656] = Fluid3D([13361,12463,12893,12830],0); -ELEMENTS[28657] = Fluid3D([17491,17247,17171,17207],0); -ELEMENTS[28658] = Fluid3D([11328,10555,11692,11629],0); -ELEMENTS[28659] = Fluid3D([11328,10555,11629,10621],0); -ELEMENTS[28660] = Fluid3D([11692,11328,11629,12382],0); -ELEMENTS[28661] = Fluid3D([10555,11692,11629,11411],0); -ELEMENTS[28662] = Fluid3D([11629,10555,11411,10806],0); -ELEMENTS[28663] = Fluid3D([10555,11411,10806,9853],0); -ELEMENTS[28664] = Fluid3D([10555,11692,11411,10811],0); -ELEMENTS[28665] = Fluid3D([11629,10555,10806,10621],0); -ELEMENTS[28666] = Fluid3D([11692,11629,11411,12358],0); -ELEMENTS[28667] = Fluid3D([11629,11411,12358,11988],0); -ELEMENTS[28668] = Fluid3D([12358,11629,11988,12046],0); -ELEMENTS[28669] = Fluid3D([11411,12358,11988,12589],0); -ELEMENTS[28670] = Fluid3D([11692,11629,12358,12382],0); -ELEMENTS[28671] = Fluid3D([11411,11629,10806,11988],0); -ELEMENTS[28672] = Fluid3D([7472,8412,7829,8006],0); -ELEMENTS[28673] = Fluid3D([12121,11933,12835,12106],0); -ELEMENTS[28674] = Fluid3D([12835,12121,12106,12521],0); -ELEMENTS[28675] = Fluid3D([12121,11933,12106,11201],0); -ELEMENTS[28676] = Fluid3D([11933,12835,12106,12328],0); -ELEMENTS[28677] = Fluid3D([14493,13765,14216,14389],0); -ELEMENTS[28678] = Fluid3D([7098,7488,7568,7966],0); -ELEMENTS[28679] = Fluid3D([9214,8501,8935,8052],0); -ELEMENTS[28680] = Fluid3D([9384,9863,10110,8962],0); -ELEMENTS[28681] = Fluid3D([8196,8545,7542,8462],0); -ELEMENTS[28682] = Fluid3D([14720,14983,14343,15375],0); -ELEMENTS[28683] = Fluid3D([13185,13077,12292,12327],0); -ELEMENTS[28684] = Fluid3D([16309,16519,16500,16974],0); -ELEMENTS[28685] = Fluid3D([13205,12335,12478,12639],0); -ELEMENTS[28686] = Fluid3D([9804,9104,9372,10028],0); -ELEMENTS[28687] = Fluid3D([9372,9804,10028,10343],0); -ELEMENTS[28688] = Fluid3D([9804,10028,10343,10946],0); -ELEMENTS[28689] = Fluid3D([9804,9104,10028,9934],0); -ELEMENTS[28690] = Fluid3D([9372,9804,10343,9590],0); -ELEMENTS[28691] = Fluid3D([9372,9804,9590,8776],0); -ELEMENTS[28692] = Fluid3D([10343,9372,9590,9815],0); -ELEMENTS[28693] = Fluid3D([9590,10343,9815,10465],0); -ELEMENTS[28694] = Fluid3D([9804,10343,9590,11033],0); -ELEMENTS[28695] = Fluid3D([9815,9590,10465,9419],0); -ELEMENTS[28696] = Fluid3D([9815,9590,9419,8492],0); -ELEMENTS[28697] = Fluid3D([10465,9815,9419,10336],0); -ELEMENTS[28698] = Fluid3D([9815,9419,10336,9499],0); -ELEMENTS[28699] = Fluid3D([9815,9419,9499,8492],0); -ELEMENTS[28700] = Fluid3D([10336,9815,9499,10502],0); -ELEMENTS[28701] = Fluid3D([10336,9815,10502,10465],0); -ELEMENTS[28702] = Fluid3D([9419,10336,9499,9685],0); -ELEMENTS[28703] = Fluid3D([10336,9499,9685,10277],0); -ELEMENTS[28704] = Fluid3D([9499,9685,10277,9265],0); -ELEMENTS[28705] = Fluid3D([9685,10336,10277,10668],0); -ELEMENTS[28706] = Fluid3D([9685,10336,10668,10293],0); -ELEMENTS[28707] = Fluid3D([9499,9419,9685,8783],0); -ELEMENTS[28708] = Fluid3D([10277,9685,10668,10249],0); -ELEMENTS[28709] = Fluid3D([10336,10277,10668,11509],0); -ELEMENTS[28710] = Fluid3D([10336,9499,10277,10502],0); -ELEMENTS[28711] = Fluid3D([9815,10502,10465,10343],0); -ELEMENTS[28712] = Fluid3D([9815,10502,10343,9372],0); -ELEMENTS[28713] = Fluid3D([9419,10336,9685,9519],0); -ELEMENTS[28714] = Fluid3D([9590,10343,10465,11033],0); -ELEMENTS[28715] = Fluid3D([9372,9590,9815,8492],0); -ELEMENTS[28716] = Fluid3D([9104,9372,10028,10016],0); -ELEMENTS[28717] = Fluid3D([9372,10028,10016,10343],0); -ELEMENTS[28718] = Fluid3D([10028,10016,10343,10993],0); -ELEMENTS[28719] = Fluid3D([6169,6628,6575,6984],0); -ELEMENTS[28720] = Fluid3D([6628,6575,6984,7344],0); -ELEMENTS[28721] = Fluid3D([6575,6984,7344,7236],0); -ELEMENTS[28722] = Fluid3D([6169,6628,6984,6615],0); -ELEMENTS[28723] = Fluid3D([6575,6169,6984,6253],0); -ELEMENTS[28724] = Fluid3D([6628,6575,7344,6677],0); -ELEMENTS[28725] = Fluid3D([6984,6628,7344,7402],0); -ELEMENTS[28726] = Fluid3D([6628,7344,7402,7024],0); -ELEMENTS[28727] = Fluid3D([6984,6628,7402,6615],0); -ELEMENTS[28728] = Fluid3D([7344,6984,7402,8246],0); -ELEMENTS[28729] = Fluid3D([2258,2404,2152,2289],0); -ELEMENTS[28730] = Fluid3D([17188,17484,17076,17178],0); -ELEMENTS[28731] = Fluid3D([17188,17484,17178,17476],0); -ELEMENTS[28732] = Fluid3D([17076,17188,17178,16720],0); -ELEMENTS[28733] = Fluid3D([17484,17178,17476,17690],0); -ELEMENTS[28734] = Fluid3D([17476,17484,17690,17717],0); -ELEMENTS[28735] = Fluid3D([17690,17476,17717,17466],0); -ELEMENTS[28736] = Fluid3D([17476,17717,17466,17518],0); -ELEMENTS[28737] = Fluid3D([17690,17476,17466,17178],0); -ELEMENTS[28738] = Fluid3D([17466,17476,17518,16931],0); -ELEMENTS[28739] = Fluid3D([17476,17717,17518,17377],0); -ELEMENTS[28740] = Fluid3D([17476,17466,17178,16931],0); -ELEMENTS[28741] = Fluid3D([17188,17484,17476,17572],0); -ELEMENTS[28742] = Fluid3D([17178,17188,17476,16931],0); -ELEMENTS[28743] = Fluid3D([17484,17076,17178,17325],0); -ELEMENTS[28744] = Fluid3D([17484,17076,17325,17537],0); -ELEMENTS[28745] = Fluid3D([17325,17484,17537,17599],0); -ELEMENTS[28746] = Fluid3D([17537,17325,17599,17328],0); -ELEMENTS[28747] = Fluid3D([17537,17325,17328,17076],0); -ELEMENTS[28748] = Fluid3D([17325,17328,17076,16882],0); -ELEMENTS[28749] = Fluid3D([17325,17328,16882,17310],0); -ELEMENTS[28750] = Fluid3D([17076,17325,16882,17178],0); -ELEMENTS[28751] = Fluid3D([17178,17484,17325,17690],0); -ELEMENTS[28752] = Fluid3D([8054,9107,8494,8181],0); -ELEMENTS[28753] = Fluid3D([15678,15108,15667,15360],0); -ELEMENTS[28754] = Fluid3D([9890,9141,9121,9050],0); -ELEMENTS[28755] = Fluid3D([8593,9572,9189,8859],0); -ELEMENTS[28756] = Fluid3D([15612,15727,15835,16273],0); -ELEMENTS[28757] = Fluid3D([3330,2914,2957,3149],0); -ELEMENTS[28758] = Fluid3D([13748,12900,12956,13266],0); -ELEMENTS[28759] = Fluid3D([13340,12648,13414,13401],0); -ELEMENTS[28760] = Fluid3D([12591,13484,13027,12442],0); -ELEMENTS[28761] = Fluid3D([6299,5778,6153,6871],0); -ELEMENTS[28762] = Fluid3D([12356,12897,13269,12707],0); -ELEMENTS[28763] = Fluid3D([5005,5020,5590,4889],0); -ELEMENTS[28764] = Fluid3D([5020,5590,4889,5212],0); -ELEMENTS[28765] = Fluid3D([5590,5005,4889,5225],0); -ELEMENTS[28766] = Fluid3D([5590,4889,5212,5595],0); -ELEMENTS[28767] = Fluid3D([5005,5020,4889,4464],0); -ELEMENTS[28768] = Fluid3D([5005,4889,5225,4603],0); -ELEMENTS[28769] = Fluid3D([5020,5590,5212,5606],0); -ELEMENTS[28770] = Fluid3D([5590,5005,5225,5617],0); -ELEMENTS[28771] = Fluid3D([5590,5005,5617,5470],0); -ELEMENTS[28772] = Fluid3D([5225,5590,5617,5969],0); -ELEMENTS[28773] = Fluid3D([5617,5225,5969,5556],0); -ELEMENTS[28774] = Fluid3D([5969,5617,5556,5586],0); -ELEMENTS[28775] = Fluid3D([5617,5556,5586,4968],0); -ELEMENTS[28776] = Fluid3D([5617,5225,5556,4968],0); -ELEMENTS[28777] = Fluid3D([5005,5225,5617,4968],0); -ELEMENTS[28778] = Fluid3D([5005,5225,4968,4603],0); -ELEMENTS[28779] = Fluid3D([5617,5005,4968,5489],0); -ELEMENTS[28780] = Fluid3D([4889,5590,5225,5595],0); -ELEMENTS[28781] = Fluid3D([4889,5020,5212,4629],0); -ELEMENTS[28782] = Fluid3D([5020,5212,4629,4972],0); -ELEMENTS[28783] = Fluid3D([4889,5020,4629,4464],0); -ELEMENTS[28784] = Fluid3D([5020,4629,4464,4614],0); -ELEMENTS[28785] = Fluid3D([4629,4464,4614,3930],0); -ELEMENTS[28786] = Fluid3D([4629,4889,4464,4292],0); -ELEMENTS[28787] = Fluid3D([4464,4629,4292,3930],0); -ELEMENTS[28788] = Fluid3D([4629,4889,4292,4661],0); -ELEMENTS[28789] = Fluid3D([4292,4629,4661,4276],0); -ELEMENTS[28790] = Fluid3D([4629,4889,4661,5212],0); -ELEMENTS[28791] = Fluid3D([5212,4629,4972,4763],0); -ELEMENTS[28792] = Fluid3D([5020,5212,4972,5606],0); -ELEMENTS[28793] = Fluid3D([4629,5020,4972,4614],0); -ELEMENTS[28794] = Fluid3D([4972,4629,4614,4395],0); -ELEMENTS[28795] = Fluid3D([4629,4614,4395,3930],0); -ELEMENTS[28796] = Fluid3D([9569,9748,10538,9660],0); -ELEMENTS[28797] = Fluid3D([5676,5919,5812,6565],0); -ELEMENTS[28798] = Fluid3D([9551,9974,9180,10027],0); -ELEMENTS[28799] = Fluid3D([17627,17777,17660,17983],0); -ELEMENTS[28800] = Fluid3D([9999,10656,9696,10048],0); -ELEMENTS[28801] = Fluid3D([13431,13281,12639,13036],0); -ELEMENTS[28802] = Fluid3D([6751,7043,6269,6457],0); -ELEMENTS[28803] = Fluid3D([7148,6488,7124,7189],0); -ELEMENTS[28804] = Fluid3D([6898,7081,6278,7135],0); -ELEMENTS[28805] = Fluid3D([17979,18213,17996,17857],0); -ELEMENTS[28806] = Fluid3D([17996,17979,17857,17787],0); -ELEMENTS[28807] = Fluid3D([17979,17857,17787,17593],0); -ELEMENTS[28808] = Fluid3D([3760,3440,3805,3866],0); -ELEMENTS[28809] = Fluid3D([3440,3805,3866,3511],0); -ELEMENTS[28810] = Fluid3D([3866,3440,3511,3488],0); -ELEMENTS[28811] = Fluid3D([3440,3511,3488,3156],0); -ELEMENTS[28812] = Fluid3D([3866,3440,3488,3760],0); -ELEMENTS[28813] = Fluid3D([3805,3760,3866,4521],0); -ELEMENTS[28814] = Fluid3D([3511,3866,3488,3688],0); -ELEMENTS[28815] = Fluid3D([5894,5302,5549,5980],0); -ELEMENTS[28816] = Fluid3D([10266,10690,10803,9943],0); -ELEMENTS[28817] = Fluid3D([14603,14692,15034,15343],0); -ELEMENTS[28818] = Fluid3D([16726,16945,16365,16433],0); -ELEMENTS[28819] = Fluid3D([16945,16365,16433,16202],0); -ELEMENTS[28820] = Fluid3D([11349,11614,12448,11415],0); -ELEMENTS[28821] = Fluid3D([11349,11614,11415,10915],0); -ELEMENTS[28822] = Fluid3D([11415,11349,10915,10389],0); -ELEMENTS[28823] = Fluid3D([10915,11415,10389,10401],0); -ELEMENTS[28824] = Fluid3D([10389,10915,10401,10100],0); -ELEMENTS[28825] = Fluid3D([10389,10915,10100,11349],0); -ELEMENTS[28826] = Fluid3D([10915,10401,10100,9839],0); -ELEMENTS[28827] = Fluid3D([10401,10389,10100,9467],0); -ELEMENTS[28828] = Fluid3D([10389,10100,9467,10245],0); -ELEMENTS[28829] = Fluid3D([10915,10100,11349,11019],0); -ELEMENTS[28830] = Fluid3D([10915,10100,11019,9839],0); -ELEMENTS[28831] = Fluid3D([11349,10915,11019,11614],0); -ELEMENTS[28832] = Fluid3D([10389,10100,10245,11349],0); -ELEMENTS[28833] = Fluid3D([10915,11019,11614,10401],0); -ELEMENTS[28834] = Fluid3D([10915,11019,10401,9839],0); -ELEMENTS[28835] = Fluid3D([12020,12152,11236,12001],0); -ELEMENTS[28836] = Fluid3D([5728,5699,5345,6008],0); -ELEMENTS[28837] = Fluid3D([5699,5345,6008,5270],0); -ELEMENTS[28838] = Fluid3D([5699,5345,5270,4746],0); -ELEMENTS[28839] = Fluid3D([5728,5699,6008,6263],0); -ELEMENTS[28840] = Fluid3D([5345,5728,6008,5778],0); -ELEMENTS[28841] = Fluid3D([5345,6008,5270,5610],0); -ELEMENTS[28842] = Fluid3D([14604,15329,15175,15399],0); -ELEMENTS[28843] = Fluid3D([8783,9419,8492,9499],0); -ELEMENTS[28844] = Fluid3D([8364,8537,7804,7969],0); -ELEMENTS[28845] = Fluid3D([7427,6564,6707,7142],0); -ELEMENTS[28846] = Fluid3D([7427,6564,7142,7042],0); -ELEMENTS[28847] = Fluid3D([6707,7427,7142,7599],0); -ELEMENTS[28848] = Fluid3D([6564,6707,7142,6413],0); -ELEMENTS[28849] = Fluid3D([7142,6564,6413,6072],0); -ELEMENTS[28850] = Fluid3D([6707,7142,6413,7582],0); -ELEMENTS[28851] = Fluid3D([6564,6707,6413,6186],0); -ELEMENTS[28852] = Fluid3D([6413,6564,6186,5775],0); -ELEMENTS[28853] = Fluid3D([6707,6413,6186,6433],0); -ELEMENTS[28854] = Fluid3D([6186,6707,6433,6407],0); -ELEMENTS[28855] = Fluid3D([6707,6413,6433,7026],0); -ELEMENTS[28856] = Fluid3D([6564,6707,6186,5930],0); -ELEMENTS[28857] = Fluid3D([6413,6186,6433,5772],0); -ELEMENTS[28858] = Fluid3D([6186,6433,5772,5861],0); -ELEMENTS[28859] = Fluid3D([6433,5772,5861,5814],0); -ELEMENTS[28860] = Fluid3D([6186,6433,5861,6407],0); -ELEMENTS[28861] = Fluid3D([5772,6186,5861,5356],0); -ELEMENTS[28862] = Fluid3D([6433,5861,6407,5814],0); -ELEMENTS[28863] = Fluid3D([5861,5772,5356,5307],0); -ELEMENTS[28864] = Fluid3D([5861,5772,5307,5814],0); -ELEMENTS[28865] = Fluid3D([5772,5356,5307,5605],0); -ELEMENTS[28866] = Fluid3D([6413,6186,5772,5775],0); -ELEMENTS[28867] = Fluid3D([6433,6413,5772,6168],0); -ELEMENTS[28868] = Fluid3D([6413,5772,6168,5605],0); -ELEMENTS[28869] = Fluid3D([16225,16482,16003,15814],0); -ELEMENTS[28870] = Fluid3D([6416,6193,6630,7023],0); -ELEMENTS[28871] = Fluid3D([6630,6416,7023,7223],0); -ELEMENTS[28872] = Fluid3D([12290,11320,12255,12112],0); -ELEMENTS[28873] = Fluid3D([13733,14461,14024,14623],0); -ELEMENTS[28874] = Fluid3D([13733,14461,14623,13746],0); -ELEMENTS[28875] = Fluid3D([13117,12198,12871,12478],0); -ELEMENTS[28876] = Fluid3D([5971,6182,6669,5752],0); -ELEMENTS[28877] = Fluid3D([4175,4518,4727,4388],0); -ELEMENTS[28878] = Fluid3D([6002,5374,5872,5494],0); -ELEMENTS[28879] = Fluid3D([14685,14880,14882,14190],0); -ELEMENTS[28880] = Fluid3D([11271,12088,11164,11576],0); -ELEMENTS[28881] = Fluid3D([7753,7655,7113,7973],0); -ELEMENTS[28882] = Fluid3D([7753,7655,7973,8850],0); -ELEMENTS[28883] = Fluid3D([7655,7113,7973,7393],0); -ELEMENTS[28884] = Fluid3D([7655,7113,7393,6809],0); -ELEMENTS[28885] = Fluid3D([7973,7655,7393,8221],0); -ELEMENTS[28886] = Fluid3D([7973,7655,8221,8850],0); -ELEMENTS[28887] = Fluid3D([7655,7393,8221,7820],0); -ELEMENTS[28888] = Fluid3D([7113,7753,7973,7854],0); -ELEMENTS[28889] = Fluid3D([7753,7973,7854,8613],0); -ELEMENTS[28890] = Fluid3D([7973,7854,8613,7897],0); -ELEMENTS[28891] = Fluid3D([8613,7973,7897,8750],0); -ELEMENTS[28892] = Fluid3D([8613,7973,8750,8850],0); -ELEMENTS[28893] = Fluid3D([7973,7854,7897,7113],0); -ELEMENTS[28894] = Fluid3D([7113,7973,7393,7223],0); -ELEMENTS[28895] = Fluid3D([7393,7973,8221,8103],0); -ELEMENTS[28896] = Fluid3D([8221,7393,8103,8188],0); -ELEMENTS[28897] = Fluid3D([8103,8221,8188,8750],0); -ELEMENTS[28898] = Fluid3D([8103,8221,8750,7973],0); -ELEMENTS[28899] = Fluid3D([8221,8750,7973,8850],0); -ELEMENTS[28900] = Fluid3D([13563,12654,13035,12721],0); -ELEMENTS[28901] = Fluid3D([12728,13376,12824,12481],0); -ELEMENTS[28902] = Fluid3D([3403,3307,3023,3574],0); -ELEMENTS[28903] = Fluid3D([14787,14434,14170,14221],0); -ELEMENTS[28904] = Fluid3D([14434,14170,14221,13473],0); -ELEMENTS[28905] = Fluid3D([14170,14787,14221,13929],0); -ELEMENTS[28906] = Fluid3D([14787,14434,14221,14878],0); -ELEMENTS[28907] = Fluid3D([17335,17434,17019,17444],0); -ELEMENTS[28908] = Fluid3D([8355,7785,7831,7731],0); -ELEMENTS[28909] = Fluid3D([12264,11835,11365,11537],0); -ELEMENTS[28910] = Fluid3D([10221,11184,10994,11172],0); -ELEMENTS[28911] = Fluid3D([9798,9618,9564,10621],0); -ELEMENTS[28912] = Fluid3D([16972,17227,17136,16900],0); -ELEMENTS[28913] = Fluid3D([12187,11664,12378,11147],0); -ELEMENTS[28914] = Fluid3D([12378,12187,11147,12105],0); -ELEMENTS[28915] = Fluid3D([11664,12378,11147,11523],0); -ELEMENTS[28916] = Fluid3D([12378,11147,11523,12105],0); -ELEMENTS[28917] = Fluid3D([11147,11523,12105,11327],0); -ELEMENTS[28918] = Fluid3D([12105,11147,11327,12187],0); -ELEMENTS[28919] = Fluid3D([12187,11664,11147,10978],0); -ELEMENTS[28920] = Fluid3D([4117,3960,3687,4132],0); -ELEMENTS[28921] = Fluid3D([4117,3960,4132,4378],0); -ELEMENTS[28922] = Fluid3D([3687,4117,4132,3957],0); -ELEMENTS[28923] = Fluid3D([3687,4117,3957,3699],0); -ELEMENTS[28924] = Fluid3D([4117,4132,3957,4620],0); -ELEMENTS[28925] = Fluid3D([3960,3687,4132,3842],0); -ELEMENTS[28926] = Fluid3D([4132,3960,3842,4324],0); -ELEMENTS[28927] = Fluid3D([3960,3842,4324,3908],0); -ELEMENTS[28928] = Fluid3D([3960,3687,3842,3518],0); -ELEMENTS[28929] = Fluid3D([3960,3842,3908,3518],0); -ELEMENTS[28930] = Fluid3D([3960,3687,3518,3646],0); -ELEMENTS[28931] = Fluid3D([3687,3842,3518,3419],0); -ELEMENTS[28932] = Fluid3D([3842,3518,3419,3592],0); -ELEMENTS[28933] = Fluid3D([3518,3687,3419,3254],0); -ELEMENTS[28934] = Fluid3D([3518,3687,3254,3646],0); -ELEMENTS[28935] = Fluid3D([3687,3419,3254,3333],0); -ELEMENTS[28936] = Fluid3D([3254,3687,3333,3646],0); -ELEMENTS[28937] = Fluid3D([3687,3842,3419,3794],0); -ELEMENTS[28938] = Fluid3D([4132,3960,4324,4378],0); -ELEMENTS[28939] = Fluid3D([3687,4132,3842,3794],0); -ELEMENTS[28940] = Fluid3D([3842,4324,3908,4091],0); -ELEMENTS[28941] = Fluid3D([4132,3687,3957,3794],0); -ELEMENTS[28942] = Fluid3D([3687,3957,3794,3676],0); -ELEMENTS[28943] = Fluid3D([3957,3794,3676,4193],0); -ELEMENTS[28944] = Fluid3D([3957,3794,4193,4132],0); -ELEMENTS[28945] = Fluid3D([3687,3957,3676,3699],0); -ELEMENTS[28946] = Fluid3D([3957,3676,3699,4107],0); -ELEMENTS[28947] = Fluid3D([3842,4132,4324,4467],0); -ELEMENTS[28948] = Fluid3D([4324,3960,3908,4300],0); -ELEMENTS[28949] = Fluid3D([4324,3960,4300,4378],0); -ELEMENTS[28950] = Fluid3D([3960,3908,4300,3692],0); -ELEMENTS[28951] = Fluid3D([3908,4324,4300,4497],0); -ELEMENTS[28952] = Fluid3D([3419,3518,3254,3123],0); -ELEMENTS[28953] = Fluid3D([3419,3518,3123,3592],0); -ELEMENTS[28954] = Fluid3D([3518,3254,3123,3181],0); -ELEMENTS[28955] = Fluid3D([3518,3254,3181,3646],0); -ELEMENTS[28956] = Fluid3D([3254,3419,3123,3179],0); -ELEMENTS[28957] = Fluid3D([3254,3419,3179,3333],0); -ELEMENTS[28958] = Fluid3D([3419,3123,3179,3261],0); -ELEMENTS[28959] = Fluid3D([3179,3419,3261,3600],0); -ELEMENTS[28960] = Fluid3D([3179,3254,3333,2946],0); -ELEMENTS[28961] = Fluid3D([3254,3333,2946,3223],0); -ELEMENTS[28962] = Fluid3D([3254,3333,3223,3646],0); -ELEMENTS[28963] = Fluid3D([3419,3123,3261,3592],0); -ELEMENTS[28964] = Fluid3D([3254,3123,3181,2946],0); -ELEMENTS[28965] = Fluid3D([3123,3518,3181,3289],0); -ELEMENTS[28966] = Fluid3D([3123,3518,3289,3592],0); -ELEMENTS[28967] = Fluid3D([3518,3181,3289,3692],0); -ELEMENTS[28968] = Fluid3D([3181,3123,3289,2904],0); -ELEMENTS[28969] = Fluid3D([3123,3289,2904,3127],0); -ELEMENTS[28970] = Fluid3D([3181,3123,2904,2868],0); -ELEMENTS[28971] = Fluid3D([3181,3123,2868,2946],0); -ELEMENTS[28972] = Fluid3D([3123,2904,2868,2745],0); -ELEMENTS[28973] = Fluid3D([3123,2904,2745,3127],0); -ELEMENTS[28974] = Fluid3D([3289,3181,2904,3233],0); -ELEMENTS[28975] = Fluid3D([3289,3181,3233,3692],0); -ELEMENTS[28976] = Fluid3D([3181,2904,3233,2913],0); -ELEMENTS[28977] = Fluid3D([3233,3181,2913,3381],0); -ELEMENTS[28978] = Fluid3D([2904,3289,3233,3014],0); -ELEMENTS[28979] = Fluid3D([2904,3289,3014,3127],0); -ELEMENTS[28980] = Fluid3D([3181,2904,2913,2868],0); -ELEMENTS[28981] = Fluid3D([2868,3123,2745,2739],0); -ELEMENTS[28982] = Fluid3D([2904,2868,2745,2638],0); -ELEMENTS[28983] = Fluid3D([2904,2868,2638,2913],0); -ELEMENTS[28984] = Fluid3D([2868,2745,2638,2592],0); -ELEMENTS[28985] = Fluid3D([2745,2904,2638,2748],0); -ELEMENTS[28986] = Fluid3D([2932,3180,3136,2863],0); -ELEMENTS[28987] = Fluid3D([3136,2932,2863,2912],0); -ELEMENTS[28988] = Fluid3D([2932,3180,2863,2721],0); -ELEMENTS[28989] = Fluid3D([3180,3136,2863,3164],0); -ELEMENTS[28990] = Fluid3D([3136,2863,3164,2912],0); -ELEMENTS[28991] = Fluid3D([3164,3136,2912,3202],0); -ELEMENTS[28992] = Fluid3D([16898,16895,17123,17168],0); -ELEMENTS[28993] = Fluid3D([15720,15979,15666,16254],0); -ELEMENTS[28994] = Fluid3D([10351,10749,11196,11866],0); -ELEMENTS[28995] = Fluid3D([12921,12079,12803,12157],0); -ELEMENTS[28996] = Fluid3D([7374,6945,6518,7118],0); -ELEMENTS[28997] = Fluid3D([3772,3318,3512,3462],0); -ELEMENTS[28998] = Fluid3D([3141,3515,3485,3203],0); -ELEMENTS[28999] = Fluid3D([13576,13922,13343,13091],0); -ELEMENTS[29000] = Fluid3D([6217,5813,5835,6459],0); -ELEMENTS[29001] = Fluid3D([9712,8945,9392,8947],0); -ELEMENTS[29002] = Fluid3D([9712,8945,8947,9120],0); -ELEMENTS[29003] = Fluid3D([17836,18044,17974,18088],0); -ELEMENTS[29004] = Fluid3D([17836,18044,18088,17752],0); -ELEMENTS[29005] = Fluid3D([9969,9798,9108,9853],0); -ELEMENTS[29006] = Fluid3D([12019,12717,12504,13176],0); -ELEMENTS[29007] = Fluid3D([12717,12504,13176,12378],0); -ELEMENTS[29008] = Fluid3D([8512,8181,8976,9206],0); -ELEMENTS[29009] = Fluid3D([11096,11951,11932,11518],0); -ELEMENTS[29010] = Fluid3D([14463,15137,14706,14648],0); -ELEMENTS[29011] = Fluid3D([11576,11774,12507,12088],0); -ELEMENTS[29012] = Fluid3D([4303,4089,3812,4071],0); -ELEMENTS[29013] = Fluid3D([11136,11244,10613,10273],0); -ELEMENTS[29014] = Fluid3D([9661,10184,9908,9243],0); -ELEMENTS[29015] = Fluid3D([10184,9908,9243,10352],0); -ELEMENTS[29016] = Fluid3D([9908,9661,9243,8907],0); -ELEMENTS[29017] = Fluid3D([9661,10184,9243,8792],0); -ELEMENTS[29018] = Fluid3D([12728,12824,12239,11554],0); -ELEMENTS[29019] = Fluid3D([16068,15858,16115,15757],0); -ELEMENTS[29020] = Fluid3D([16115,16068,15757,16312],0); -ELEMENTS[29021] = Fluid3D([16068,15757,16312,15879],0); -ELEMENTS[29022] = Fluid3D([15757,16312,15879,16177],0); -ELEMENTS[29023] = Fluid3D([15757,16115,16312,16177],0); -ELEMENTS[29024] = Fluid3D([16068,15858,15757,15550],0); -ELEMENTS[29025] = Fluid3D([15858,16115,15757,15954],0); -ELEMENTS[29026] = Fluid3D([16115,15757,15954,16177],0); -ELEMENTS[29027] = Fluid3D([16312,16068,15879,16588],0); -ELEMENTS[29028] = Fluid3D([15858,16115,15954,16286],0); -ELEMENTS[29029] = Fluid3D([16115,15954,16286,16484],0); -ELEMENTS[29030] = Fluid3D([16115,15954,16484,16177],0); -ELEMENTS[29031] = Fluid3D([16068,15757,15879,15565],0); -ELEMENTS[29032] = Fluid3D([16115,16068,16312,16444],0); -ELEMENTS[29033] = Fluid3D([3951,4176,3881,3604],0); -ELEMENTS[29034] = Fluid3D([14156,14341,13545,14077],0); -ELEMENTS[29035] = Fluid3D([13545,14156,14077,13103],0); -ELEMENTS[29036] = Fluid3D([14156,14341,14077,14820],0); -ELEMENTS[29037] = Fluid3D([14341,13545,14077,13989],0); -ELEMENTS[29038] = Fluid3D([13545,14077,13989,13103],0); -ELEMENTS[29039] = Fluid3D([14077,14341,13989,14805],0); -ELEMENTS[29040] = Fluid3D([13989,14077,14805,14368],0); -ELEMENTS[29041] = Fluid3D([13989,14077,14368,13612],0); -ELEMENTS[29042] = Fluid3D([14077,14805,14368,14820],0); -ELEMENTS[29043] = Fluid3D([14805,13989,14368,14752],0); -ELEMENTS[29044] = Fluid3D([14077,14341,14805,14820],0); -ELEMENTS[29045] = Fluid3D([14077,14368,13612,13333],0); -ELEMENTS[29046] = Fluid3D([13989,14077,13612,13333],0); -ELEMENTS[29047] = Fluid3D([14341,13989,14805,14869],0); -ELEMENTS[29048] = Fluid3D([13989,14805,14869,14752],0); -ELEMENTS[29049] = Fluid3D([14805,14341,14869,15385],0); -ELEMENTS[29050] = Fluid3D([14341,13989,14869,13775],0); -ELEMENTS[29051] = Fluid3D([14368,13989,13612,14046],0); -ELEMENTS[29052] = Fluid3D([14368,13989,14046,14752],0); -ELEMENTS[29053] = Fluid3D([13989,13612,14046,13366],0); -ELEMENTS[29054] = Fluid3D([13989,14046,14752,14633],0); -ELEMENTS[29055] = Fluid3D([13989,14046,14633,14012],0); -ELEMENTS[29056] = Fluid3D([14046,13989,13366,14012],0); -ELEMENTS[29057] = Fluid3D([14046,14633,14012,14878],0); -ELEMENTS[29058] = Fluid3D([14046,14633,14878,14752],0); -ELEMENTS[29059] = Fluid3D([14633,14012,14878,15087],0); -ELEMENTS[29060] = Fluid3D([14878,14633,15087,15272],0); -ELEMENTS[29061] = Fluid3D([14878,14633,15272,14752],0); -ELEMENTS[29062] = Fluid3D([14633,15087,15272,14869],0); -ELEMENTS[29063] = Fluid3D([14633,15087,14869,14516],0); -ELEMENTS[29064] = Fluid3D([15087,14878,15272,15687],0); -ELEMENTS[29065] = Fluid3D([14878,15272,15687,14752],0); -ELEMENTS[29066] = Fluid3D([15272,15687,14752,15462],0); -ELEMENTS[29067] = Fluid3D([15272,15087,15687,15839],0); -ELEMENTS[29068] = Fluid3D([15272,14633,14869,14752],0); -ELEMENTS[29069] = Fluid3D([14633,15087,14516,14012],0); -ELEMENTS[29070] = Fluid3D([15272,15687,15462,15484],0); -ELEMENTS[29071] = Fluid3D([15272,15687,15484,15735],0); -ELEMENTS[29072] = Fluid3D([15272,15687,15735,15839],0); -ELEMENTS[29073] = Fluid3D([15087,14878,15687,15839],0); -ELEMENTS[29074] = Fluid3D([14869,14633,14516,13989],0); -ELEMENTS[29075] = Fluid3D([14869,14633,13989,14752],0); -ELEMENTS[29076] = Fluid3D([15484,15272,15735,15232],0); -ELEMENTS[29077] = Fluid3D([15087,15272,14869,15232],0); -ELEMENTS[29078] = Fluid3D([14805,14869,14752,15272],0); -ELEMENTS[29079] = Fluid3D([14805,14869,15272,15484],0); -ELEMENTS[29080] = Fluid3D([14805,14869,15484,15385],0); -ELEMENTS[29081] = Fluid3D([15272,14805,15484,14752],0); -ELEMENTS[29082] = Fluid3D([15484,15272,14752,15462],0); -ELEMENTS[29083] = Fluid3D([12619,13507,12845,12986],0); -ELEMENTS[29084] = Fluid3D([6761,6368,5996,6251],0); -ELEMENTS[29085] = Fluid3D([7658,7667,7319,8492],0); -ELEMENTS[29086] = Fluid3D([6563,7409,7363,6867],0); -ELEMENTS[29087] = Fluid3D([11377,11782,11551,12408],0); -ELEMENTS[29088] = Fluid3D([18522,18388,18524,18417],0); -ELEMENTS[29089] = Fluid3D([13387,12658,12880,13741],0); -ELEMENTS[29090] = Fluid3D([12155,12667,13079,12153],0); -ELEMENTS[29091] = Fluid3D([4745,4679,4337,4025],0); -ELEMENTS[29092] = Fluid3D([15717,15707,16177,16130],0); -ELEMENTS[29093] = Fluid3D([16177,15717,16130,16180],0); -ELEMENTS[29094] = Fluid3D([15717,16130,16180,15506],0); -ELEMENTS[29095] = Fluid3D([16130,16180,15506,15962],0); -ELEMENTS[29096] = Fluid3D([16130,16180,15962,16568],0); -ELEMENTS[29097] = Fluid3D([16130,16180,16568,16766],0); -ELEMENTS[29098] = Fluid3D([15717,15707,16130,15506],0); -ELEMENTS[29099] = Fluid3D([15707,16177,16130,15954],0); -ELEMENTS[29100] = Fluid3D([15962,16130,16568,16045],0); -ELEMENTS[29101] = Fluid3D([17252,17405,16977,17248],0); -ELEMENTS[29102] = Fluid3D([11742,11376,11984,12321],0); -ELEMENTS[29103] = Fluid3D([6811,7378,7315,7598],0); -ELEMENTS[29104] = Fluid3D([6811,7378,7598,7089],0); -ELEMENTS[29105] = Fluid3D([7598,6811,7089,6763],0); -ELEMENTS[29106] = Fluid3D([7378,7315,7598,8124],0); -ELEMENTS[29107] = Fluid3D([7378,7315,8124,7545],0); -ELEMENTS[29108] = Fluid3D([7315,8124,7545,7910],0); -ELEMENTS[29109] = Fluid3D([7545,7315,7910,6934],0); -ELEMENTS[29110] = Fluid3D([7545,7315,6934,6838],0); -ELEMENTS[29111] = Fluid3D([7545,7315,6838,7378],0); -ELEMENTS[29112] = Fluid3D([7598,7378,8124,7727],0); -ELEMENTS[29113] = Fluid3D([7315,6811,7598,6763],0); -ELEMENTS[29114] = Fluid3D([7315,7598,8124,7595],0); -ELEMENTS[29115] = Fluid3D([4937,5486,5065,5382],0); -ELEMENTS[29116] = Fluid3D([5065,4937,5382,4657],0); -ELEMENTS[29117] = Fluid3D([4937,5486,5382,5352],0); -ELEMENTS[29118] = Fluid3D([5486,5065,5382,5607],0); -ELEMENTS[29119] = Fluid3D([5065,5382,5607,5216],0); -ELEMENTS[29120] = Fluid3D([5382,5607,5216,5390],0); -ELEMENTS[29121] = Fluid3D([5382,5607,5390,5779],0); -ELEMENTS[29122] = Fluid3D([5382,5607,5779,5486],0); -ELEMENTS[29123] = Fluid3D([5390,5382,5779,5352],0); -ELEMENTS[29124] = Fluid3D([5607,5216,5390,5823],0); -ELEMENTS[29125] = Fluid3D([5216,5382,5390,4657],0); -ELEMENTS[29126] = Fluid3D([5779,5382,5486,5352],0); -ELEMENTS[29127] = Fluid3D([9177,9519,9685,10157],0); -ELEMENTS[29128] = Fluid3D([9519,9685,10157,10293],0); -ELEMENTS[29129] = Fluid3D([10157,9519,10293,9385],0); -ELEMENTS[29130] = Fluid3D([9177,9519,10157,9385],0); -ELEMENTS[29131] = Fluid3D([9685,9177,10157,9837],0); -ELEMENTS[29132] = Fluid3D([14575,14691,14257,15193],0); -ELEMENTS[29133] = Fluid3D([11276,10970,11616,11321],0); -ELEMENTS[29134] = Fluid3D([15399,15329,15039,14604],0); -ELEMENTS[29135] = Fluid3D([16658,16839,16605,16924],0); -ELEMENTS[29136] = Fluid3D([16605,16658,16924,16162],0); -ELEMENTS[29137] = Fluid3D([12511,11996,12333,12950],0); -ELEMENTS[29138] = Fluid3D([11996,12333,12950,12273],0); -ELEMENTS[29139] = Fluid3D([12333,12511,12950,13192],0); -ELEMENTS[29140] = Fluid3D([12950,12333,13192,12732],0); -ELEMENTS[29141] = Fluid3D([12511,11996,12950,12541],0); -ELEMENTS[29142] = Fluid3D([12333,12511,13192,12254],0); -ELEMENTS[29143] = Fluid3D([12511,12950,13192,13580],0); -ELEMENTS[29144] = Fluid3D([13192,12511,13580,13242],0); -ELEMENTS[29145] = Fluid3D([5459,5775,6072,5605],0); -ELEMENTS[29146] = Fluid3D([11926,12846,12327,11739],0); -ELEMENTS[29147] = Fluid3D([15828,15188,15344,15162],0); -ELEMENTS[29148] = Fluid3D([15507,15859,15204,15316],0); -ELEMENTS[29149] = Fluid3D([6510,6076,6711,6842],0); -ELEMENTS[29150] = Fluid3D([16833,17147,17129,17198],0); -ELEMENTS[29151] = Fluid3D([3647,3668,3789,3335],0); -ELEMENTS[29152] = Fluid3D([3050,2665,2801,2649],0); -ELEMENTS[29153] = Fluid3D([16918,17219,16979,16599],0); -ELEMENTS[29154] = Fluid3D([7037,7899,7600,7650],0); -ELEMENTS[29155] = Fluid3D([7037,7899,7650,7502],0); -ELEMENTS[29156] = Fluid3D([7899,7600,7650,8405],0); -ELEMENTS[29157] = Fluid3D([7600,7037,7650,6688],0); -ELEMENTS[29158] = Fluid3D([11748,11636,11439,12387],0); -ELEMENTS[29159] = Fluid3D([11636,11439,12387,12379],0); -ELEMENTS[29160] = Fluid3D([12387,11636,12379,12359],0); -ELEMENTS[29161] = Fluid3D([11439,11748,12387,11986],0); -ELEMENTS[29162] = Fluid3D([11748,11636,12387,12359],0); -ELEMENTS[29163] = Fluid3D([6719,6998,6200,6476],0); -ELEMENTS[29164] = Fluid3D([6719,6998,6476,7392],0); -ELEMENTS[29165] = Fluid3D([6200,6719,6476,5992],0); -ELEMENTS[29166] = Fluid3D([6998,6200,6476,6112],0); -ELEMENTS[29167] = Fluid3D([6200,6476,6112,5992],0); -ELEMENTS[29168] = Fluid3D([6200,6719,5992,6204],0); -ELEMENTS[29169] = Fluid3D([6719,6476,5992,6879],0); -ELEMENTS[29170] = Fluid3D([12206,11299,11898,12069],0); -ELEMENTS[29171] = Fluid3D([17128,17463,17138,17033],0); -ELEMENTS[29172] = Fluid3D([13015,12890,12830,12126],0); -ELEMENTS[29173] = Fluid3D([12890,12830,12126,12463],0); -ELEMENTS[29174] = Fluid3D([13015,12890,12126,12659],0); -ELEMENTS[29175] = Fluid3D([12830,13015,12126,11895],0); -ELEMENTS[29176] = Fluid3D([12126,12830,11895,11886],0); -ELEMENTS[29177] = Fluid3D([11895,12126,11886,10876],0); -ELEMENTS[29178] = Fluid3D([12126,12830,11886,12463],0); -ELEMENTS[29179] = Fluid3D([7320,8304,8120,7746],0); -ELEMENTS[29180] = Fluid3D([8304,8120,7746,8466],0); -ELEMENTS[29181] = Fluid3D([8120,7746,8466,7525],0); -ELEMENTS[29182] = Fluid3D([7746,8466,7525,7701],0); -ELEMENTS[29183] = Fluid3D([7746,8466,7701,8030],0); -ELEMENTS[29184] = Fluid3D([7746,8466,8030,8304],0); -ELEMENTS[29185] = Fluid3D([7701,7746,8030,7089],0); -ELEMENTS[29186] = Fluid3D([8120,7746,7525,7320],0); -ELEMENTS[29187] = Fluid3D([7320,8304,7746,7166],0); -ELEMENTS[29188] = Fluid3D([10340,9477,9374,10104],0); -ELEMENTS[29189] = Fluid3D([3719,4153,4037,3904],0); -ELEMENTS[29190] = Fluid3D([3719,4153,3904,3868],0); -ELEMENTS[29191] = Fluid3D([4153,4037,3904,4364],0); -ELEMENTS[29192] = Fluid3D([3904,4153,4364,4296],0); -ELEMENTS[29193] = Fluid3D([4153,4037,4364,4566],0); -ELEMENTS[29194] = Fluid3D([4037,3904,4364,4097],0); -ELEMENTS[29195] = Fluid3D([3904,4364,4097,4296],0); -ELEMENTS[29196] = Fluid3D([4037,3719,3904,3727],0); -ELEMENTS[29197] = Fluid3D([3904,4037,3727,4097],0); -ELEMENTS[29198] = Fluid3D([4037,3719,3727,3617],0); -ELEMENTS[29199] = Fluid3D([3719,3904,3727,3565],0); -ELEMENTS[29200] = Fluid3D([3904,3727,3565,4097],0); -ELEMENTS[29201] = Fluid3D([6412,6863,7143,6910],0); -ELEMENTS[29202] = Fluid3D([7143,6412,6910,6554],0); -ELEMENTS[29203] = Fluid3D([6412,6910,6554,6072],0); -ELEMENTS[29204] = Fluid3D([6412,6863,6910,6196],0); -ELEMENTS[29205] = Fluid3D([7143,6412,6554,6938],0); -ELEMENTS[29206] = Fluid3D([6863,7143,6910,8007],0); -ELEMENTS[29207] = Fluid3D([6910,7143,6554,7657],0); -ELEMENTS[29208] = Fluid3D([14861,15189,14579,14738],0); -ELEMENTS[29209] = Fluid3D([8351,8102,8745,7443],0); -ELEMENTS[29210] = Fluid3D([7496,6864,6926,7418],0); -ELEMENTS[29211] = Fluid3D([6864,6926,7418,6583],0); -ELEMENTS[29212] = Fluid3D([6926,7418,6583,7185],0); -ELEMENTS[29213] = Fluid3D([7418,6864,6583,6946],0); -ELEMENTS[29214] = Fluid3D([7418,6864,6946,7634],0); -ELEMENTS[29215] = Fluid3D([6864,6583,6946,6188],0); -ELEMENTS[29216] = Fluid3D([6946,6864,6188,6747],0); -ELEMENTS[29217] = Fluid3D([6864,6926,6583,6146],0); -ELEMENTS[29218] = Fluid3D([9307,10310,10093,9513],0); -ELEMENTS[29219] = Fluid3D([9801,8878,9362,8289],0); -ELEMENTS[29220] = Fluid3D([14777,13894,14557,14248],0); -ELEMENTS[29221] = Fluid3D([13894,14557,14248,13719],0); -ELEMENTS[29222] = Fluid3D([14557,14777,14248,15112],0); -ELEMENTS[29223] = Fluid3D([14777,13894,14248,14498],0); -ELEMENTS[29224] = Fluid3D([14248,14777,14498,15112],0); -ELEMENTS[29225] = Fluid3D([14557,14248,13719,14651],0); -ELEMENTS[29226] = Fluid3D([14557,14248,14651,15112],0); -ELEMENTS[29227] = Fluid3D([14248,13719,14651,13661],0); -ELEMENTS[29228] = Fluid3D([14651,14248,13661,14336],0); -ELEMENTS[29229] = Fluid3D([14248,13661,14336,13921],0); -ELEMENTS[29230] = Fluid3D([13661,14336,13921,13844],0); -ELEMENTS[29231] = Fluid3D([13661,14651,14336,14305],0); -ELEMENTS[29232] = Fluid3D([14651,14248,14336,14498],0); -ELEMENTS[29233] = Fluid3D([13661,14336,13844,14305],0); -ELEMENTS[29234] = Fluid3D([14248,14336,14498,13921],0); -ELEMENTS[29235] = Fluid3D([14498,14248,13921,13369],0); -ELEMENTS[29236] = Fluid3D([14248,13661,13921,13369],0); -ELEMENTS[29237] = Fluid3D([14248,13719,13661,13369],0); -ELEMENTS[29238] = Fluid3D([13894,14557,13719,13827],0); -ELEMENTS[29239] = Fluid3D([14248,13894,13719,13369],0); -ELEMENTS[29240] = Fluid3D([14012,13929,14221,14672],0); -ELEMENTS[29241] = Fluid3D([13929,14221,14672,14787],0); -ELEMENTS[29242] = Fluid3D([14221,14672,14787,14878],0); -ELEMENTS[29243] = Fluid3D([14672,14787,14878,15018],0); -ELEMENTS[29244] = Fluid3D([14672,14787,15018,13929],0); -ELEMENTS[29245] = Fluid3D([14878,14672,15018,15315],0); -ELEMENTS[29246] = Fluid3D([15018,14672,13929,14809],0); -ELEMENTS[29247] = Fluid3D([14672,15018,15315,14809],0); -ELEMENTS[29248] = Fluid3D([14221,14012,14672,14878],0); -ELEMENTS[29249] = Fluid3D([14012,14672,14878,15087],0); -ELEMENTS[29250] = Fluid3D([14672,14878,15087,15315],0); -ELEMENTS[29251] = Fluid3D([14012,13929,14672,14592],0); -ELEMENTS[29252] = Fluid3D([14672,14012,14592,15087],0); -ELEMENTS[29253] = Fluid3D([14592,14672,15087,15315],0); -ELEMENTS[29254] = Fluid3D([11780,10781,11186,11382],0); -ELEMENTS[29255] = Fluid3D([8841,9268,9583,8822],0); -ELEMENTS[29256] = Fluid3D([6628,7024,6677,7344],0); -ELEMENTS[29257] = Fluid3D([2465,2372,2234,2261],0); -ELEMENTS[29258] = Fluid3D([10378,10959,10612,9330],0); -ELEMENTS[29259] = Fluid3D([16488,15854,16035,15953],0); -ELEMENTS[29260] = Fluid3D([16488,15854,15953,16136],0); -ELEMENTS[29261] = Fluid3D([16035,16488,15953,16405],0); -ELEMENTS[29262] = Fluid3D([16488,15953,16405,16623],0); -ELEMENTS[29263] = Fluid3D([15854,15953,16136,15664],0); -ELEMENTS[29264] = Fluid3D([15854,15953,15664,15378],0); -ELEMENTS[29265] = Fluid3D([15664,15854,15378,15230],0); -ELEMENTS[29266] = Fluid3D([15664,15854,15230,15749],0); -ELEMENTS[29267] = Fluid3D([15230,15664,15749,15154],0); -ELEMENTS[29268] = Fluid3D([15230,15664,15154,14891],0); -ELEMENTS[29269] = Fluid3D([15664,15854,15749,16136],0); -ELEMENTS[29270] = Fluid3D([15749,15230,15154,15209],0); -ELEMENTS[29271] = Fluid3D([15230,15154,15209,14621],0); -ELEMENTS[29272] = Fluid3D([15154,15209,14621,14920],0); -ELEMENTS[29273] = Fluid3D([14621,15154,14920,14807],0); -ELEMENTS[29274] = Fluid3D([14621,15154,14807,14891],0); -ELEMENTS[29275] = Fluid3D([15154,14920,14807,15503],0); -ELEMENTS[29276] = Fluid3D([15154,14920,15503,15749],0); -ELEMENTS[29277] = Fluid3D([14807,15154,15503,15339],0); -ELEMENTS[29278] = Fluid3D([14920,14621,14807,14043],0); -ELEMENTS[29279] = Fluid3D([14621,15154,14891,15230],0); -ELEMENTS[29280] = Fluid3D([15154,15209,14920,15749],0); -ELEMENTS[29281] = Fluid3D([14920,14807,15503,15080],0); -ELEMENTS[29282] = Fluid3D([15503,14920,15080,15582],0); -ELEMENTS[29283] = Fluid3D([15503,14920,15582,15749],0); -ELEMENTS[29284] = Fluid3D([15080,15503,15582,15600],0); -ELEMENTS[29285] = Fluid3D([14920,15080,15582,14775],0); -ELEMENTS[29286] = Fluid3D([14920,15080,14775,14807],0); -ELEMENTS[29287] = Fluid3D([15080,15503,15600,14807],0); -ELEMENTS[29288] = Fluid3D([15503,14807,15339,15600],0); -ELEMENTS[29289] = Fluid3D([15749,15230,15209,15931],0); -ELEMENTS[29290] = Fluid3D([15378,15664,15230,14891],0); -ELEMENTS[29291] = Fluid3D([15854,15953,15378,16035],0); -ELEMENTS[29292] = Fluid3D([15953,16136,15664,15961],0); -ELEMENTS[29293] = Fluid3D([15953,16136,15961,16623],0); -ELEMENTS[29294] = Fluid3D([16136,15664,15961,16213],0); -ELEMENTS[29295] = Fluid3D([15961,16136,16213,16623],0); -ELEMENTS[29296] = Fluid3D([15664,15953,15961,15436],0); -ELEMENTS[29297] = Fluid3D([15953,15961,15436,16002],0); -ELEMENTS[29298] = Fluid3D([15961,15436,16002,15492],0); -ELEMENTS[29299] = Fluid3D([15664,15953,15436,15378],0); -ELEMENTS[29300] = Fluid3D([15953,15961,16002,16623],0); -ELEMENTS[29301] = Fluid3D([15436,15953,16002,15585],0); -ELEMENTS[29302] = Fluid3D([15953,16002,15585,16405],0); -ELEMENTS[29303] = Fluid3D([16002,15436,15585,15444],0); -ELEMENTS[29304] = Fluid3D([15436,15585,15444,14495],0); -ELEMENTS[29305] = Fluid3D([15436,15953,15585,15378],0); -ELEMENTS[29306] = Fluid3D([16002,15436,15444,15492],0); -ELEMENTS[29307] = Fluid3D([15585,16002,15444,15971],0); -ELEMENTS[29308] = Fluid3D([16002,15444,15971,15975],0); -ELEMENTS[29309] = Fluid3D([15444,15585,15971,15374],0); -ELEMENTS[29310] = Fluid3D([15444,15585,15374,14495],0); -ELEMENTS[29311] = Fluid3D([15585,15971,15374,15775],0); -ELEMENTS[29312] = Fluid3D([15585,16002,15971,16405],0); -ELEMENTS[29313] = Fluid3D([16002,15444,15975,15492],0); -ELEMENTS[29314] = Fluid3D([15444,15971,15975,15794],0); -ELEMENTS[29315] = Fluid3D([15975,15444,15794,15492],0); -ELEMENTS[29316] = Fluid3D([15961,15664,15436,15366],0); -ELEMENTS[29317] = Fluid3D([15961,15664,15366,16213],0); -ELEMENTS[29318] = Fluid3D([15664,15436,15366,14891],0); -ELEMENTS[29319] = Fluid3D([15436,15961,15366,15806],0); -ELEMENTS[29320] = Fluid3D([15961,15366,15806,16213],0); -ELEMENTS[29321] = Fluid3D([15806,15961,16213,16428],0); -ELEMENTS[29322] = Fluid3D([15664,15749,15154,15503],0); -ELEMENTS[29323] = Fluid3D([15953,16488,16136,16623],0); -ELEMENTS[29324] = Fluid3D([15854,15378,15230,15617],0); -ELEMENTS[29325] = Fluid3D([15971,15444,15374,15594],0); -ELEMENTS[29326] = Fluid3D([15444,15374,15594,14972],0); -ELEMENTS[29327] = Fluid3D([15594,15444,14972,15213],0); -ELEMENTS[29328] = Fluid3D([15374,15971,15594,15775],0); -ELEMENTS[29329] = Fluid3D([15971,15444,15594,15794],0); -ELEMENTS[29330] = Fluid3D([15594,15444,15213,15794],0); -ELEMENTS[29331] = Fluid3D([15213,15594,15794,15434],0); -ELEMENTS[29332] = Fluid3D([15594,15794,15434,15629],0); -ELEMENTS[29333] = Fluid3D([14972,15594,15213,15434],0); -ELEMENTS[29334] = Fluid3D([15444,15374,14972,14495],0); -ELEMENTS[29335] = Fluid3D([15374,15594,14972,14760],0); -ELEMENTS[29336] = Fluid3D([15444,14972,15213,14831],0); -ELEMENTS[29337] = Fluid3D([14972,15213,14831,14481],0); -ELEMENTS[29338] = Fluid3D([15213,15444,14831,15492],0); -ELEMENTS[29339] = Fluid3D([15444,14972,14831,14495],0); -ELEMENTS[29340] = Fluid3D([14831,14972,14481,14178],0); -ELEMENTS[29341] = Fluid3D([14972,14481,14178,14760],0); -ELEMENTS[29342] = Fluid3D([14178,14972,14760,14530],0); -ELEMENTS[29343] = Fluid3D([14178,14972,14530,14495],0); -ELEMENTS[29344] = Fluid3D([14972,15213,14481,14924],0); -ELEMENTS[29345] = Fluid3D([14972,15213,14924,15434],0); -ELEMENTS[29346] = Fluid3D([15213,14924,15434,14960],0); -ELEMENTS[29347] = Fluid3D([14924,15434,14960,14423],0); -ELEMENTS[29348] = Fluid3D([14960,14924,14423,14481],0); -ELEMENTS[29349] = Fluid3D([14924,15434,14423,14710],0); -ELEMENTS[29350] = Fluid3D([14423,14924,14710,13883],0); -ELEMENTS[29351] = Fluid3D([14924,15434,14710,15629],0); -ELEMENTS[29352] = Fluid3D([14924,14423,14481,13883],0); -ELEMENTS[29353] = Fluid3D([15213,14924,14960,14481],0); -ELEMENTS[29354] = Fluid3D([14481,14972,14924,14760],0); -ELEMENTS[29355] = Fluid3D([15213,14831,14481,14863],0); -ELEMENTS[29356] = Fluid3D([15213,14831,14863,15492],0); -ELEMENTS[29357] = Fluid3D([14831,14481,14863,14186],0); -ELEMENTS[29358] = Fluid3D([14481,15213,14863,14960],0); -ELEMENTS[29359] = Fluid3D([15854,15230,15749,15931],0); -ELEMENTS[29360] = Fluid3D([16488,15854,16136,16355],0); -ELEMENTS[29361] = Fluid3D([15971,16002,15975,16379],0); -ELEMENTS[29362] = Fluid3D([8660,8770,8648,7844],0); -ELEMENTS[29363] = Fluid3D([14537,15263,15297,15393],0); -ELEMENTS[29364] = Fluid3D([16783,16450,16620,16032],0); -ELEMENTS[29365] = Fluid3D([15645,16119,16099,15515],0); -ELEMENTS[29366] = Fluid3D([8789,9584,8859,8672],0); -ELEMENTS[29367] = Fluid3D([3519,3406,3801,3369],0); -ELEMENTS[29368] = Fluid3D([5622,5367,4965,5669],0); -ELEMENTS[29369] = Fluid3D([12357,11945,12924,11935],0); -ELEMENTS[29370] = Fluid3D([3590,3173,3285,3187],0); -ELEMENTS[29371] = Fluid3D([18143,17841,18014,18088],0); -ELEMENTS[29372] = Fluid3D([6691,5910,6355,5855],0); -ELEMENTS[29373] = Fluid3D([12787,12017,11872,11944],0); -ELEMENTS[29374] = Fluid3D([17540,17811,17677,17794],0); -ELEMENTS[29375] = Fluid3D([17540,17811,17794,17543],0); -ELEMENTS[29376] = Fluid3D([12957,13123,12222,12389],0); -ELEMENTS[29377] = Fluid3D([12222,12957,12389,12271],0); -ELEMENTS[29378] = Fluid3D([11530,12664,11777,12038],0); -ELEMENTS[29379] = Fluid3D([16211,16145,16606,16229],0); -ELEMENTS[29380] = Fluid3D([16606,16211,16229,16626],0); -ELEMENTS[29381] = Fluid3D([16211,16229,16626,16416],0); -ELEMENTS[29382] = Fluid3D([16626,16211,16416,16804],0); -ELEMENTS[29383] = Fluid3D([16416,16626,16804,16981],0); -ELEMENTS[29384] = Fluid3D([16626,16804,16981,16606],0); -ELEMENTS[29385] = Fluid3D([16606,16211,16626,16804],0); -ELEMENTS[29386] = Fluid3D([15251,16009,15758,15628],0); -ELEMENTS[29387] = Fluid3D([12189,11461,12252,11758],0); -ELEMENTS[29388] = Fluid3D([12252,12189,11758,12825],0); -ELEMENTS[29389] = Fluid3D([3654,3840,3986,4113],0); -ELEMENTS[29390] = Fluid3D([3654,3840,4113,3810],0); -ELEMENTS[29391] = Fluid3D([3986,3654,4113,3874],0); -ELEMENTS[29392] = Fluid3D([3840,3986,4113,4383],0); -ELEMENTS[29393] = Fluid3D([4113,3840,4383,3952],0); -ELEMENTS[29394] = Fluid3D([4383,4113,3952,4327],0); -ELEMENTS[29395] = Fluid3D([3986,4113,4383,4160],0); -ELEMENTS[29396] = Fluid3D([4113,3840,3952,3810],0); -ELEMENTS[29397] = Fluid3D([3840,3952,3810,3410],0); -ELEMENTS[29398] = Fluid3D([3952,4113,3810,4327],0); -ELEMENTS[29399] = Fluid3D([3952,3810,3410,3618],0); -ELEMENTS[29400] = Fluid3D([3840,3952,3410,3575],0); -ELEMENTS[29401] = Fluid3D([3840,3952,3575,4145],0); -ELEMENTS[29402] = Fluid3D([3840,3952,4145,4383],0); -ELEMENTS[29403] = Fluid3D([4827,4610,5223,5167],0); -ELEMENTS[29404] = Fluid3D([5223,4827,5167,5718],0); -ELEMENTS[29405] = Fluid3D([4827,4610,5167,4810],0); -ELEMENTS[29406] = Fluid3D([4610,5167,4810,5082],0); -ELEMENTS[29407] = Fluid3D([5167,4810,5082,5411],0); -ELEMENTS[29408] = Fluid3D([5167,4810,5411,4827],0); -ELEMENTS[29409] = Fluid3D([5082,5167,5411,5640],0); -ELEMENTS[29410] = Fluid3D([5082,5167,5640,5223],0); -ELEMENTS[29411] = Fluid3D([5167,5411,5640,5718],0); -ELEMENTS[29412] = Fluid3D([5167,5411,5718,4827],0); -ELEMENTS[29413] = Fluid3D([5640,5167,5718,5223],0); -ELEMENTS[29414] = Fluid3D([4610,5167,5082,5223],0); -ELEMENTS[29415] = Fluid3D([5411,5640,5718,5887],0); -ELEMENTS[29416] = Fluid3D([5640,5082,5223,5771],0); -ELEMENTS[29417] = Fluid3D([5411,5082,5640,5557],0); -ELEMENTS[29418] = Fluid3D([5082,5640,5557,5614],0); -ELEMENTS[29419] = Fluid3D([4810,4610,5082,4684],0); -ELEMENTS[29420] = Fluid3D([4810,4610,4684,4101],0); -ELEMENTS[29421] = Fluid3D([5082,4810,4684,5267],0); -ELEMENTS[29422] = Fluid3D([17998,17929,18188,18095],0); -ELEMENTS[29423] = Fluid3D([10920,10049,10524,9865],0); -ELEMENTS[29424] = Fluid3D([12047,11038,11549,11554],0); -ELEMENTS[29425] = Fluid3D([6562,7007,6729,6204],0); -ELEMENTS[29426] = Fluid3D([16668,16272,16778,16426],0); -ELEMENTS[29427] = Fluid3D([7784,7354,6997,6901],0); -ELEMENTS[29428] = Fluid3D([7354,6997,6901,6661],0); -ELEMENTS[29429] = Fluid3D([14359,13558,13784,13777],0); -ELEMENTS[29430] = Fluid3D([13558,13784,13777,12995],0); -ELEMENTS[29431] = Fluid3D([13777,13558,12995,12979],0); -ELEMENTS[29432] = Fluid3D([13777,13558,12979,14373],0); -ELEMENTS[29433] = Fluid3D([14725,13805,14517,14480],0); -ELEMENTS[29434] = Fluid3D([9923,9544,9306,10258],0); -ELEMENTS[29435] = Fluid3D([9544,9306,10258,9785],0); -ELEMENTS[29436] = Fluid3D([9923,9544,10258,10978],0); -ELEMENTS[29437] = Fluid3D([9306,9923,10258,9958],0); -ELEMENTS[29438] = Fluid3D([9306,9923,9958,8935],0); -ELEMENTS[29439] = Fluid3D([9958,9306,8935,9533],0); -ELEMENTS[29440] = Fluid3D([7180,7005,7062,8217],0); -ELEMENTS[29441] = Fluid3D([12479,13092,12159,12212],0); -ELEMENTS[29442] = Fluid3D([5354,5028,5671,5651],0); -ELEMENTS[29443] = Fluid3D([10831,9761,10010,10666],0); -ELEMENTS[29444] = Fluid3D([13642,12773,13400,12815],0); -ELEMENTS[29445] = Fluid3D([16217,16202,16672,16433],0); -ELEMENTS[29446] = Fluid3D([15808,15744,15603,16277],0); -ELEMENTS[29447] = Fluid3D([13598,13599,13454,14241],0); -ELEMENTS[29448] = Fluid3D([13598,13599,14241,14381],0); -ELEMENTS[29449] = Fluid3D([13454,13598,14241,14409],0); -ELEMENTS[29450] = Fluid3D([14241,13454,14409,14460],0); -ELEMENTS[29451] = Fluid3D([13599,13454,14241,13943],0); -ELEMENTS[29452] = Fluid3D([14241,13599,13943,14287],0); -ELEMENTS[29453] = Fluid3D([13599,13943,14287,14351],0); -ELEMENTS[29454] = Fluid3D([13943,14287,14351,14808],0); -ELEMENTS[29455] = Fluid3D([14287,14351,14808,15105],0); -ELEMENTS[29456] = Fluid3D([14287,14351,15105,14711],0); -ELEMENTS[29457] = Fluid3D([14287,14351,14711,14365],0); -ELEMENTS[29458] = Fluid3D([14287,14351,14365,13622],0); -ELEMENTS[29459] = Fluid3D([13943,14287,14808,14241],0); -ELEMENTS[29460] = Fluid3D([14711,14287,14365,13622],0); -ELEMENTS[29461] = Fluid3D([14287,14808,14241,14711],0); -ELEMENTS[29462] = Fluid3D([14287,14808,14711,15105],0); -ELEMENTS[29463] = Fluid3D([13599,13454,13943,12922],0); -ELEMENTS[29464] = Fluid3D([14241,13599,14287,14381],0); -ELEMENTS[29465] = Fluid3D([13454,14241,13943,14460],0); -ELEMENTS[29466] = Fluid3D([7597,7356,8163,7713],0); -ELEMENTS[29467] = Fluid3D([5607,6040,6126,6144],0); -ELEMENTS[29468] = Fluid3D([6126,5607,6144,5811],0); -ELEMENTS[29469] = Fluid3D([6040,6126,6144,6821],0); -ELEMENTS[29470] = Fluid3D([5607,6040,6144,5823],0); -ELEMENTS[29471] = Fluid3D([6040,6144,5823,6557],0); -ELEMENTS[29472] = Fluid3D([6144,5823,6557,6489],0); -ELEMENTS[29473] = Fluid3D([5823,6557,6489,6223],0); -ELEMENTS[29474] = Fluid3D([6557,6489,6223,7000],0); -ELEMENTS[29475] = Fluid3D([5823,6557,6223,6040],0); -ELEMENTS[29476] = Fluid3D([6040,6144,6557,6821],0); -ELEMENTS[29477] = Fluid3D([6557,6040,6821,6223],0); -ELEMENTS[29478] = Fluid3D([6557,6144,6489,6966],0); -ELEMENTS[29479] = Fluid3D([6489,6557,6966,7403],0); -ELEMENTS[29480] = Fluid3D([2432,2171,2326,2260],0); -ELEMENTS[29481] = Fluid3D([8568,9217,9510,8567],0); -ELEMENTS[29482] = Fluid3D([9510,8568,8567,9107],0); -ELEMENTS[29483] = Fluid3D([9348,9846,9567,8880],0); -ELEMENTS[29484] = Fluid3D([9348,9846,8880,9389],0); -ELEMENTS[29485] = Fluid3D([9846,9567,8880,9443],0); -ELEMENTS[29486] = Fluid3D([8880,9846,9443,8977],0); -ELEMENTS[29487] = Fluid3D([9443,8880,8977,8505],0); -ELEMENTS[29488] = Fluid3D([9443,8880,8505,8770],0); -ELEMENTS[29489] = Fluid3D([9567,9348,8880,8549],0); -ELEMENTS[29490] = Fluid3D([9348,8880,8549,7934],0); -ELEMENTS[29491] = Fluid3D([8880,9567,8549,8770],0); -ELEMENTS[29492] = Fluid3D([9567,9348,8549,8948],0); -ELEMENTS[29493] = Fluid3D([12881,12441,13125,12001],0); -ELEMENTS[29494] = Fluid3D([8643,8668,9083,9321],0); -ELEMENTS[29495] = Fluid3D([8668,9083,9321,9373],0); -ELEMENTS[29496] = Fluid3D([9321,8668,9373,8968],0); -ELEMENTS[29497] = Fluid3D([4923,4798,4564,5303],0); -ELEMENTS[29498] = Fluid3D([12464,12844,13249,12751],0); -ELEMENTS[29499] = Fluid3D([6776,6591,6038,6617],0); -ELEMENTS[29500] = Fluid3D([5664,5806,6179,6039],0); -ELEMENTS[29501] = Fluid3D([11830,11794,11206,11254],0); -ELEMENTS[29502] = Fluid3D([13698,14059,13393,13554],0); -ELEMENTS[29503] = Fluid3D([12444,11815,11475,12041],0); -ELEMENTS[29504] = Fluid3D([11815,11475,12041,11590],0); -ELEMENTS[29505] = Fluid3D([12444,11815,12041,13075],0); -ELEMENTS[29506] = Fluid3D([11475,12444,12041,12432],0); -ELEMENTS[29507] = Fluid3D([4047,4302,4084,3787],0); -ELEMENTS[29508] = Fluid3D([16323,16449,16580,15849],0); -ELEMENTS[29509] = Fluid3D([12443,11866,11460,12282],0); -ELEMENTS[29510] = Fluid3D([11460,12443,12282,12228],0); -ELEMENTS[29511] = Fluid3D([12443,12282,12228,13057],0); -ELEMENTS[29512] = Fluid3D([10114,10263,10711,9475],0); -ELEMENTS[29513] = Fluid3D([13205,13655,13861,14140],0); -ELEMENTS[29514] = Fluid3D([7615,7968,7465,8398],0); -ELEMENTS[29515] = Fluid3D([3893,4183,4130,4558],0); -ELEMENTS[29516] = Fluid3D([10531,10119,10673,9464],0); -ELEMENTS[29517] = Fluid3D([6390,6532,6805,6034],0); -ELEMENTS[29518] = Fluid3D([6390,6532,6034,5853],0); -ELEMENTS[29519] = Fluid3D([6805,6390,6034,6181],0); -ELEMENTS[29520] = Fluid3D([6532,6805,6034,6553],0); -ELEMENTS[29521] = Fluid3D([6034,6532,6553,5733],0); -ELEMENTS[29522] = Fluid3D([6532,6805,6553,7112],0); -ELEMENTS[29523] = Fluid3D([6805,6034,6553,6284],0); -ELEMENTS[29524] = Fluid3D([6034,6553,6284,6182],0); -ELEMENTS[29525] = Fluid3D([6553,6284,6182,6953],0); -ELEMENTS[29526] = Fluid3D([6284,6182,6953,6302],0); -ELEMENTS[29527] = Fluid3D([6182,6553,6953,6669],0); -ELEMENTS[29528] = Fluid3D([6553,6284,6953,6805],0); -ELEMENTS[29529] = Fluid3D([6805,6034,6284,6181],0); -ELEMENTS[29530] = Fluid3D([6953,6182,6669,6464],0); -ELEMENTS[29531] = Fluid3D([16255,15704,15880,15788],0); -ELEMENTS[29532] = Fluid3D([15704,15880,15788,14915],0); -ELEMENTS[29533] = Fluid3D([15880,16255,15788,16236],0); -ELEMENTS[29534] = Fluid3D([15880,16255,16236,16653],0); -ELEMENTS[29535] = Fluid3D([15788,15880,16236,15304],0); -ELEMENTS[29536] = Fluid3D([16255,15704,15788,15736],0); -ELEMENTS[29537] = Fluid3D([16255,15788,16236,16301],0); -ELEMENTS[29538] = Fluid3D([15788,16236,16301,16005],0); -ELEMENTS[29539] = Fluid3D([16236,16301,16005,16823],0); -ELEMENTS[29540] = Fluid3D([16255,15788,16301,15736],0); -ELEMENTS[29541] = Fluid3D([15788,16301,15736,16005],0); -ELEMENTS[29542] = Fluid3D([15736,15788,16005,15304],0); -ELEMENTS[29543] = Fluid3D([15788,16236,16005,15304],0); -ELEMENTS[29544] = Fluid3D([16236,16255,16301,16823],0); -ELEMENTS[29545] = Fluid3D([7502,7362,8153,7936],0); -ELEMENTS[29546] = Fluid3D([16976,16928,17103,17378],0); -ELEMENTS[29547] = Fluid3D([13264,13332,13754,14027],0); -ELEMENTS[29548] = Fluid3D([17415,17116,17448,17456],0); -ELEMENTS[29549] = Fluid3D([17448,17415,17456,17737],0); -ELEMENTS[29550] = Fluid3D([17456,17448,17737,17253],0); -ELEMENTS[29551] = Fluid3D([17415,17116,17456,17291],0); -ELEMENTS[29552] = Fluid3D([17415,17116,17291,16998],0); -ELEMENTS[29553] = Fluid3D([17456,17415,17291,17768],0); -ELEMENTS[29554] = Fluid3D([17116,17448,17456,17253],0); -ELEMENTS[29555] = Fluid3D([17456,17116,17253,17148],0); -ELEMENTS[29556] = Fluid3D([17116,17456,17291,17148],0); -ELEMENTS[29557] = Fluid3D([12731,12450,11852,12118],0); -ELEMENTS[29558] = Fluid3D([5051,5704,5592,5555],0); -ELEMENTS[29559] = Fluid3D([14293,14186,14290,15134],0); -ELEMENTS[29560] = Fluid3D([5745,5387,5171,5591],0); -ELEMENTS[29561] = Fluid3D([8364,9235,8537,9242],0); -ELEMENTS[29562] = Fluid3D([13657,14075,13825,12876],0); -ELEMENTS[29563] = Fluid3D([14049,14041,13413,14263],0); -ELEMENTS[29564] = Fluid3D([15824,15456,16106,15670],0); -ELEMENTS[29565] = Fluid3D([5402,5673,5351,4952],0); -ELEMENTS[29566] = Fluid3D([7253,7271,7244,6443],0); -ELEMENTS[29567] = Fluid3D([14521,15012,14883,15342],0); -ELEMENTS[29568] = Fluid3D([14521,15012,15342,14913],0); -ELEMENTS[29569] = Fluid3D([15012,14883,15342,15743],0); -ELEMENTS[29570] = Fluid3D([15342,15012,15743,15430],0); -ELEMENTS[29571] = Fluid3D([15342,15012,15430,14993],0); -ELEMENTS[29572] = Fluid3D([15342,15012,14993,14913],0); -ELEMENTS[29573] = Fluid3D([15012,15430,14993,15102],0); -ELEMENTS[29574] = Fluid3D([14383,13930,14645,13811],0); -ELEMENTS[29575] = Fluid3D([14140,14428,14727,15055],0); -ELEMENTS[29576] = Fluid3D([4537,4144,4086,4226],0); -ELEMENTS[29577] = Fluid3D([7898,7132,7491,7509],0); -ELEMENTS[29578] = Fluid3D([14082,14337,14775,14761],0); -ELEMENTS[29579] = Fluid3D([15153,15300,14818,14586],0); -ELEMENTS[29580] = Fluid3D([15153,15300,14586,15169],0); -ELEMENTS[29581] = Fluid3D([15300,14818,14586,14758],0); -ELEMENTS[29582] = Fluid3D([14586,15300,14758,14476],0); -ELEMENTS[29583] = Fluid3D([14818,14586,14758,14223],0); -ELEMENTS[29584] = Fluid3D([14818,14586,14223,14118],0); -ELEMENTS[29585] = Fluid3D([14586,14223,14118,13682],0); -ELEMENTS[29586] = Fluid3D([14818,15153,14586,14118],0); -ELEMENTS[29587] = Fluid3D([9655,10596,10109,9857],0); -ELEMENTS[29588] = Fluid3D([17594,17447,17802,17786],0); -ELEMENTS[29589] = Fluid3D([3682,3817,3549,3426],0); -ELEMENTS[29590] = Fluid3D([3549,3682,3426,3286],0); -ELEMENTS[29591] = Fluid3D([3817,3549,3426,3471],0); -ELEMENTS[29592] = Fluid3D([3682,3817,3426,4028],0); -ELEMENTS[29593] = Fluid3D([10498,9776,9649,9597],0); -ELEMENTS[29594] = Fluid3D([10498,9776,9597,10470],0); -ELEMENTS[29595] = Fluid3D([9776,9649,9597,8608],0); -ELEMENTS[29596] = Fluid3D([9649,10498,9597,9474],0); -ELEMENTS[29597] = Fluid3D([13174,13577,14014,13913],0); -ELEMENTS[29598] = Fluid3D([6859,6890,6250,6297],0); -ELEMENTS[29599] = Fluid3D([7333,8166,7213,7475],0); -ELEMENTS[29600] = Fluid3D([18246,18243,18191,18468],0); -ELEMENTS[29601] = Fluid3D([14089,14208,14738,14937],0); -ELEMENTS[29602] = Fluid3D([3784,4180,3768,3640],0); -ELEMENTS[29603] = Fluid3D([15683,15000,15492,14863],0); -ELEMENTS[29604] = Fluid3D([15000,15492,14863,15134],0); -ELEMENTS[29605] = Fluid3D([15683,15000,14863,14938],0); -ELEMENTS[29606] = Fluid3D([15000,14863,14938,13995],0); -ELEMENTS[29607] = Fluid3D([4070,3646,3960,3692],0); -ELEMENTS[29608] = Fluid3D([9434,9603,9091,10187],0); -ELEMENTS[29609] = Fluid3D([15415,15604,14965,15234],0); -ELEMENTS[29610] = Fluid3D([15251,15099,15628,15045],0); -ELEMENTS[29611] = Fluid3D([13297,13742,13046,14062],0); -ELEMENTS[29612] = Fluid3D([3017,3116,3179,2739],0); -ELEMENTS[29613] = Fluid3D([4914,4585,4723,5223],0); -ELEMENTS[29614] = Fluid3D([15866,15470,16078,16149],0); -ELEMENTS[29615] = Fluid3D([4495,4950,5043,4381],0); -ELEMENTS[29616] = Fluid3D([11552,10942,10686,10406],0); -ELEMENTS[29617] = Fluid3D([17925,17850,18131,17987],0); -ELEMENTS[29618] = Fluid3D([17925,17850,17987,17607],0); -ELEMENTS[29619] = Fluid3D([17850,18131,17987,18016],0); -ELEMENTS[29620] = Fluid3D([17987,17850,18016,17754],0); -ELEMENTS[29621] = Fluid3D([18016,17987,17754,18040],0); -ELEMENTS[29622] = Fluid3D([18016,17987,18040,18233],0); -ELEMENTS[29623] = Fluid3D([17987,18040,18233,18121],0); -ELEMENTS[29624] = Fluid3D([17987,18040,18121,17907],0); -ELEMENTS[29625] = Fluid3D([17987,17754,18040,17907],0); -ELEMENTS[29626] = Fluid3D([18016,17987,18233,18131],0); -ELEMENTS[29627] = Fluid3D([17987,18233,18131,18121],0); -ELEMENTS[29628] = Fluid3D([17850,18016,17754,17790],0); -ELEMENTS[29629] = Fluid3D([17987,17850,17754,17607],0); -ELEMENTS[29630] = Fluid3D([17850,17754,17607,17416],0); -ELEMENTS[29631] = Fluid3D([17754,17607,17416,17517],0); -ELEMENTS[29632] = Fluid3D([17754,17607,17517,17907],0); -ELEMENTS[29633] = Fluid3D([17416,17754,17517,17339],0); -ELEMENTS[29634] = Fluid3D([17754,17987,17607,17907],0); -ELEMENTS[29635] = Fluid3D([18131,17925,17987,18121],0); -ELEMENTS[29636] = Fluid3D([17925,17987,18121,17809],0); -ELEMENTS[29637] = Fluid3D([17987,18121,17809,17907],0); -ELEMENTS[29638] = Fluid3D([18121,17809,17907,17860],0); -ELEMENTS[29639] = Fluid3D([17809,17907,17860,17635],0); -ELEMENTS[29640] = Fluid3D([17809,17907,17635,17588],0); -ELEMENTS[29641] = Fluid3D([17635,17809,17588,17607],0); -ELEMENTS[29642] = Fluid3D([17907,17635,17588,17661],0); -ELEMENTS[29643] = Fluid3D([17635,17588,17661,17375],0); -ELEMENTS[29644] = Fluid3D([17635,17588,17375,17317],0); -ELEMENTS[29645] = Fluid3D([17635,17588,17317,17607],0); -ELEMENTS[29646] = Fluid3D([17588,17661,17375,17301],0); -ELEMENTS[29647] = Fluid3D([17588,17661,17301,17819],0); -ELEMENTS[29648] = Fluid3D([17588,17375,17317,17301],0); -ELEMENTS[29649] = Fluid3D([17809,17907,17588,17607],0); -ELEMENTS[29650] = Fluid3D([17860,17809,17635,17704],0); -ELEMENTS[29651] = Fluid3D([17809,17635,17704,17607],0); -ELEMENTS[29652] = Fluid3D([17860,17809,17704,17925],0); -ELEMENTS[29653] = Fluid3D([17375,17635,17317,17554],0); -ELEMENTS[29654] = Fluid3D([17907,17860,17635,17763],0); -ELEMENTS[29655] = Fluid3D([17635,17907,17763,17661],0); -ELEMENTS[29656] = Fluid3D([17860,17635,17763,17554],0); -ELEMENTS[29657] = Fluid3D([17635,17763,17554,17375],0); -ELEMENTS[29658] = Fluid3D([17704,17809,17607,17925],0); -ELEMENTS[29659] = Fluid3D([17809,17607,17925,17987],0); -ELEMENTS[29660] = Fluid3D([17809,17607,17987,17907],0); -ELEMENTS[29661] = Fluid3D([17763,17635,17661,17375],0); -ELEMENTS[29662] = Fluid3D([18121,17809,17860,17925],0); -ELEMENTS[29663] = Fluid3D([17635,17860,17704,17554],0); -ELEMENTS[29664] = Fluid3D([17661,17375,17301,17382],0); -ELEMENTS[29665] = Fluid3D([13228,13674,12833,13784],0); -ELEMENTS[29666] = Fluid3D([7580,7790,6955,7243],0); -ELEMENTS[29667] = Fluid3D([3417,3743,3820,3209],0); -ELEMENTS[29668] = Fluid3D([10392,11378,10825,11281],0); -ELEMENTS[29669] = Fluid3D([6749,6271,6618,7181],0); -ELEMENTS[29670] = Fluid3D([15021,15140,15565,15653],0); -ELEMENTS[29671] = Fluid3D([15140,15565,15653,15816],0); -ELEMENTS[29672] = Fluid3D([13310,13768,13434,12939],0); -ELEMENTS[29673] = Fluid3D([13768,13434,12939,13572],0); -ELEMENTS[29674] = Fluid3D([13434,13310,12939,12578],0); -ELEMENTS[29675] = Fluid3D([4534,4486,5047,4485],0); -ELEMENTS[29676] = Fluid3D([14066,13668,13257,14131],0); -ELEMENTS[29677] = Fluid3D([14066,13668,14131,14539],0); -ELEMENTS[29678] = Fluid3D([13257,14066,14131,13634],0); -ELEMENTS[29679] = Fluid3D([13668,13257,14131,13563],0); -ELEMENTS[29680] = Fluid3D([7664,7868,8176,7133],0); -ELEMENTS[29681] = Fluid3D([12239,13180,12633,13320],0); -ELEMENTS[29682] = Fluid3D([14857,15487,15379,15370],0); -ELEMENTS[29683] = Fluid3D([13337,13585,14147,12876],0); -ELEMENTS[29684] = Fluid3D([5546,6023,5917,6244],0); -ELEMENTS[29685] = Fluid3D([7589,6761,7147,7148],0); -ELEMENTS[29686] = Fluid3D([5639,5238,5304,5046],0); -ELEMENTS[29687] = Fluid3D([15105,15253,15472,15681],0); -ELEMENTS[29688] = Fluid3D([15105,15253,15681,15469],0); -ELEMENTS[29689] = Fluid3D([8754,8568,8599,7402],0); -ELEMENTS[29690] = Fluid3D([18130,18224,18007,17909],0); -ELEMENTS[29691] = Fluid3D([18007,18130,17909,17930],0); -ELEMENTS[29692] = Fluid3D([5020,5235,5606,5036],0); -ELEMENTS[29693] = Fluid3D([5020,5235,5036,4630],0); -ELEMENTS[29694] = Fluid3D([5235,5036,4630,4971],0); -ELEMENTS[29695] = Fluid3D([5235,5036,4971,5531],0); -ELEMENTS[29696] = Fluid3D([5235,5606,5036,5531],0); -ELEMENTS[29697] = Fluid3D([9443,9823,8977,9846],0); -ELEMENTS[29698] = Fluid3D([16726,16368,16527,16365],0); -ELEMENTS[29699] = Fluid3D([12317,11797,12257,13299],0); -ELEMENTS[29700] = Fluid3D([15935,15307,15643,15493],0); -ELEMENTS[29701] = Fluid3D([6039,5997,6523,6477],0); -ELEMENTS[29702] = Fluid3D([6039,5997,6477,5664],0); -ELEMENTS[29703] = Fluid3D([6523,6039,6477,6797],0); -ELEMENTS[29704] = Fluid3D([6523,6039,6797,6163],0); -ELEMENTS[29705] = Fluid3D([6477,6523,6797,7107],0); -ELEMENTS[29706] = Fluid3D([6477,6523,7107,5997],0); -ELEMENTS[29707] = Fluid3D([6039,6477,6797,6339],0); -ELEMENTS[29708] = Fluid3D([6039,6477,6339,6179],0); -ELEMENTS[29709] = Fluid3D([6477,6797,6339,7093],0); -ELEMENTS[29710] = Fluid3D([6339,6477,7093,6916],0); -ELEMENTS[29711] = Fluid3D([6477,7093,6916,7107],0); -ELEMENTS[29712] = Fluid3D([6916,6477,7107,5997],0); -ELEMENTS[29713] = Fluid3D([6477,7093,7107,6797],0); -ELEMENTS[29714] = Fluid3D([6797,6039,6339,5842],0); -ELEMENTS[29715] = Fluid3D([6797,6339,7093,6638],0); -ELEMENTS[29716] = Fluid3D([6797,6339,6638,5842],0); -ELEMENTS[29717] = Fluid3D([6339,7093,6638,6887],0); -ELEMENTS[29718] = Fluid3D([7701,8498,8466,8402],0); -ELEMENTS[29719] = Fluid3D([12184,12442,13140,12591],0); -ELEMENTS[29720] = Fluid3D([10434,9471,10218,10579],0); -ELEMENTS[29721] = Fluid3D([12588,13370,12706,13248],0); -ELEMENTS[29722] = Fluid3D([12588,13370,13248,13414],0); -ELEMENTS[29723] = Fluid3D([12706,12588,13248,12702],0); -ELEMENTS[29724] = Fluid3D([12588,13248,12702,13414],0); -ELEMENTS[29725] = Fluid3D([13370,12706,13248,13734],0); -ELEMENTS[29726] = Fluid3D([11908,12935,12421,12482],0); -ELEMENTS[29727] = Fluid3D([16658,16683,17080,17113],0); -ELEMENTS[29728] = Fluid3D([17080,16658,17113,16839],0); -ELEMENTS[29729] = Fluid3D([4816,4491,4542,4212],0); -ELEMENTS[29730] = Fluid3D([9822,9508,9787,8740],0); -ELEMENTS[29731] = Fluid3D([10007,10068,9429,9247],0); -ELEMENTS[29732] = Fluid3D([10007,10068,9247,10149],0); -ELEMENTS[29733] = Fluid3D([9429,10007,9247,9213],0); -ELEMENTS[29734] = Fluid3D([9429,10007,9213,10239],0); -ELEMENTS[29735] = Fluid3D([10068,9429,9247,9279],0); -ELEMENTS[29736] = Fluid3D([9247,9429,9213,8428],0); -ELEMENTS[29737] = Fluid3D([10007,9247,9213,9556],0); -ELEMENTS[29738] = Fluid3D([11121,12325,11489,12261],0); -ELEMENTS[29739] = Fluid3D([12325,11489,12261,12356],0); -ELEMENTS[29740] = Fluid3D([13790,13906,13154,13217],0); -ELEMENTS[29741] = Fluid3D([9644,10048,9741,8666],0); -ELEMENTS[29742] = Fluid3D([7073,7666,7615,6736],0); -ELEMENTS[29743] = Fluid3D([5982,5945,6117,6795],0); -ELEMENTS[29744] = Fluid3D([2995,3057,2740,2705],0); -ELEMENTS[29745] = Fluid3D([16057,15686,15434,15957],0); -ELEMENTS[29746] = Fluid3D([9084,9906,9276,9355],0); -ELEMENTS[29747] = Fluid3D([6430,6694,5980,5894],0); -ELEMENTS[29748] = Fluid3D([13737,13322,14186,13815],0); -ELEMENTS[29749] = Fluid3D([13737,13322,13815,13136],0); -ELEMENTS[29750] = Fluid3D([13322,14186,13815,13593],0); -ELEMENTS[29751] = Fluid3D([14186,13737,13815,14481],0); -ELEMENTS[29752] = Fluid3D([12473,11614,12301,12448],0); -ELEMENTS[29753] = Fluid3D([17734,17452,17535,17409],0); -ELEMENTS[29754] = Fluid3D([3273,3799,3800,3949],0); -ELEMENTS[29755] = Fluid3D([9182,8225,8615,8891],0); -ELEMENTS[29756] = Fluid3D([8970,9745,9046,9827],0); -ELEMENTS[29757] = Fluid3D([4413,3939,4285,4321],0); -ELEMENTS[29758] = Fluid3D([9992,9609,9553,10302],0); -ELEMENTS[29759] = Fluid3D([9609,9553,10302,9811],0); -ELEMENTS[29760] = Fluid3D([9992,9609,10302,10303],0); -ELEMENTS[29761] = Fluid3D([9609,10302,10303,9531],0); -ELEMENTS[29762] = Fluid3D([9609,10302,9531,9811],0); -ELEMENTS[29763] = Fluid3D([15138,14393,14812,14828],0); -ELEMENTS[29764] = Fluid3D([15138,14393,14828,15144],0); -ELEMENTS[29765] = Fluid3D([14393,14812,14828,14093],0); -ELEMENTS[29766] = Fluid3D([14812,15138,14828,15039],0); -ELEMENTS[29767] = Fluid3D([14828,14812,15039,14411],0); -ELEMENTS[29768] = Fluid3D([14812,15039,14411,14222],0); -ELEMENTS[29769] = Fluid3D([15039,14411,14222,14996],0); -ELEMENTS[29770] = Fluid3D([15039,14828,14411,14996],0); -ELEMENTS[29771] = Fluid3D([14828,14812,14411,14093],0); -ELEMENTS[29772] = Fluid3D([14812,14411,14093,14222],0); -ELEMENTS[29773] = Fluid3D([14411,14093,14222,13818],0); -ELEMENTS[29774] = Fluid3D([14411,14093,13818,13969],0); -ELEMENTS[29775] = Fluid3D([14411,14093,13969,14520],0); -ELEMENTS[29776] = Fluid3D([14411,14093,14520,14828],0); -ELEMENTS[29777] = Fluid3D([13969,14411,14520,14388],0); -ELEMENTS[29778] = Fluid3D([14520,13969,14388,14122],0); -ELEMENTS[29779] = Fluid3D([13969,14388,14122,13798],0); -ELEMENTS[29780] = Fluid3D([14520,13969,14122,13758],0); -ELEMENTS[29781] = Fluid3D([14520,13969,13758,14093],0); -ELEMENTS[29782] = Fluid3D([13969,14411,14388,13818],0); -ELEMENTS[29783] = Fluid3D([14222,14411,13818,14996],0); -ELEMENTS[29784] = Fluid3D([14388,14520,14122,14880],0); -ELEMENTS[29785] = Fluid3D([14388,14520,14880,14828],0); -ELEMENTS[29786] = Fluid3D([14880,14388,14828,14996],0); -ELEMENTS[29787] = Fluid3D([14880,14388,14996,14190],0); -ELEMENTS[29788] = Fluid3D([14880,14388,14190,14122],0); -ELEMENTS[29789] = Fluid3D([14388,14996,14190,13798],0); -ELEMENTS[29790] = Fluid3D([14828,14880,14996,15237],0); -ELEMENTS[29791] = Fluid3D([14828,14880,15237,15526],0); -ELEMENTS[29792] = Fluid3D([15237,14828,15526,15138],0); -ELEMENTS[29793] = Fluid3D([15237,14828,15138,15039],0); -ELEMENTS[29794] = Fluid3D([15237,14828,15039,14996],0); -ELEMENTS[29795] = Fluid3D([14880,15237,15526,14996],0); -ELEMENTS[29796] = Fluid3D([13969,14122,13758,13798],0); -ELEMENTS[29797] = Fluid3D([14520,14880,14828,15144],0); -ELEMENTS[29798] = Fluid3D([14828,14880,15526,15144],0); -ELEMENTS[29799] = Fluid3D([14122,14520,13758,14375],0); -ELEMENTS[29800] = Fluid3D([13969,14388,13798,13818],0); -ELEMENTS[29801] = Fluid3D([14388,14190,14122,13798],0); -ELEMENTS[29802] = Fluid3D([14388,14520,14828,14411],0); -ELEMENTS[29803] = Fluid3D([14388,14828,14996,14411],0); -ELEMENTS[29804] = Fluid3D([14996,14388,14411,13818],0); -ELEMENTS[29805] = Fluid3D([14996,14880,14190,14882],0); -ELEMENTS[29806] = Fluid3D([9797,9469,9816,10467],0); -ELEMENTS[29807] = Fluid3D([9469,9816,10467,9882],0); -ELEMENTS[29808] = Fluid3D([9797,9469,10467,9919],0); -ELEMENTS[29809] = Fluid3D([9816,9797,10467,10672],0); -ELEMENTS[29810] = Fluid3D([10467,9816,10672,11230],0); -ELEMENTS[29811] = Fluid3D([9816,9797,10672,10120],0); -ELEMENTS[29812] = Fluid3D([9797,10467,10672,11077],0); -ELEMENTS[29813] = Fluid3D([5701,6094,5458,6231],0); -ELEMENTS[29814] = Fluid3D([11082,11789,10705,10966],0); -ELEMENTS[29815] = Fluid3D([11082,11789,10966,11162],0); -ELEMENTS[29816] = Fluid3D([10966,11082,11162,10206],0); -ELEMENTS[29817] = Fluid3D([11789,10705,10966,11542],0); -ELEMENTS[29818] = Fluid3D([10705,11082,10966,10206],0); -ELEMENTS[29819] = Fluid3D([14861,15217,15305,14657],0); -ELEMENTS[29820] = Fluid3D([6079,5717,5466,6097],0); -ELEMENTS[29821] = Fluid3D([13710,14503,13301,13984],0); -ELEMENTS[29822] = Fluid3D([7817,7132,7898,7706],0); -ELEMENTS[29823] = Fluid3D([15878,15403,15294,15721],0); -ELEMENTS[29824] = Fluid3D([10959,11292,11900,12215],0); -ELEMENTS[29825] = Fluid3D([6498,6055,6605,5926],0); -ELEMENTS[29826] = Fluid3D([10143,9717,9822,10714],0); -ELEMENTS[29827] = Fluid3D([16695,16320,16290,16677],0); -ELEMENTS[29828] = Fluid3D([16099,16119,16614,16282],0); -ELEMENTS[29829] = Fluid3D([3739,3432,3692,3686],0); -ELEMENTS[29830] = Fluid3D([15576,15147,15674,14974],0); -ELEMENTS[29831] = Fluid3D([4340,4721,4673,4318],0); -ELEMENTS[29832] = Fluid3D([4340,4721,4318,4267],0); -ELEMENTS[29833] = Fluid3D([4721,4673,4318,4838],0); -ELEMENTS[29834] = Fluid3D([4721,4673,4838,5409],0); -ELEMENTS[29835] = Fluid3D([4318,4721,4838,4424],0); -ELEMENTS[29836] = Fluid3D([4838,4318,4424,4641],0); -ELEMENTS[29837] = Fluid3D([4424,4838,4641,5202],0); -ELEMENTS[29838] = Fluid3D([4424,4838,5202,4662],0); -ELEMENTS[29839] = Fluid3D([4838,4641,5202,5215],0); -ELEMENTS[29840] = Fluid3D([5202,4838,5215,5565],0); -ELEMENTS[29841] = Fluid3D([5215,5202,5565,5447],0); -ELEMENTS[29842] = Fluid3D([5202,5565,5447,5971],0); -ELEMENTS[29843] = Fluid3D([5202,4838,5565,5409],0); -ELEMENTS[29844] = Fluid3D([4838,5215,5565,5409],0); -ELEMENTS[29845] = Fluid3D([4838,4641,5215,4983],0); -ELEMENTS[29846] = Fluid3D([4673,4340,4318,4414],0); -ELEMENTS[29847] = Fluid3D([4673,4340,4414,4765],0); -ELEMENTS[29848] = Fluid3D([4673,4318,4838,4449],0); -ELEMENTS[29849] = Fluid3D([12158,11520,12394,11909],0); -ELEMENTS[29850] = Fluid3D([8470,8586,8796,7929],0); -ELEMENTS[29851] = Fluid3D([10640,9854,10859,10276],0); -ELEMENTS[29852] = Fluid3D([9854,10859,10276,10209],0); -ELEMENTS[29853] = Fluid3D([10859,10276,10209,10990],0); -ELEMENTS[29854] = Fluid3D([10276,9854,10209,9500],0); -ELEMENTS[29855] = Fluid3D([9854,10859,10209,10042],0); -ELEMENTS[29856] = Fluid3D([10276,10209,10990,10216],0); -ELEMENTS[29857] = Fluid3D([10990,10276,10216,10450],0); -ELEMENTS[29858] = Fluid3D([10276,10209,10216,9500],0); -ELEMENTS[29859] = Fluid3D([10216,10276,9500,10076],0); -ELEMENTS[29860] = Fluid3D([9500,10216,10076,10450],0); -ELEMENTS[29861] = Fluid3D([10216,10076,10450,10276],0); -ELEMENTS[29862] = Fluid3D([10076,9500,10450,9733],0); -ELEMENTS[29863] = Fluid3D([10450,10076,9733,10700],0); -ELEMENTS[29864] = Fluid3D([10076,10450,10276,10990],0); -ELEMENTS[29865] = Fluid3D([10076,10450,10990,10700],0); -ELEMENTS[29866] = Fluid3D([10276,10076,10990,10640],0); -ELEMENTS[29867] = Fluid3D([9500,10216,10450,10220],0); -ELEMENTS[29868] = Fluid3D([9500,10216,10220,9290],0); -ELEMENTS[29869] = Fluid3D([10216,10450,10220,11235],0); -ELEMENTS[29870] = Fluid3D([10220,10216,11235,10605],0); -ELEMENTS[29871] = Fluid3D([10076,9500,9733,9593],0); -ELEMENTS[29872] = Fluid3D([10216,10450,11235,10990],0); -ELEMENTS[29873] = Fluid3D([9733,10076,9593,10495],0); -ELEMENTS[29874] = Fluid3D([9733,10076,10495,10700],0); -ELEMENTS[29875] = Fluid3D([9593,9733,10495,9983],0); -ELEMENTS[29876] = Fluid3D([10495,9733,10700,9983],0); -ELEMENTS[29877] = Fluid3D([10276,9500,10076,9593],0); -ELEMENTS[29878] = Fluid3D([10216,10220,9290,10605],0); -ELEMENTS[29879] = Fluid3D([10990,10276,10640,10859],0); -ELEMENTS[29880] = Fluid3D([10450,10220,11235,11190],0); -ELEMENTS[29881] = Fluid3D([10220,11235,11190,10987],0); -ELEMENTS[29882] = Fluid3D([11235,11190,10987,11733],0); -ELEMENTS[29883] = Fluid3D([11235,11190,11733,12451],0); -ELEMENTS[29884] = Fluid3D([11235,10450,11190,11862],0); -ELEMENTS[29885] = Fluid3D([11190,11235,11862,12451],0); -ELEMENTS[29886] = Fluid3D([10220,11235,10987,10605],0); -ELEMENTS[29887] = Fluid3D([10700,10495,9983,10958],0); -ELEMENTS[29888] = Fluid3D([11190,11733,12451,11940],0); -ELEMENTS[29889] = Fluid3D([11733,12451,11940,12266],0); -ELEMENTS[29890] = Fluid3D([11733,12451,12266,11771],0); -ELEMENTS[29891] = Fluid3D([11733,12451,11771,11235],0); -ELEMENTS[29892] = Fluid3D([12266,11733,11771,11158],0); -ELEMENTS[29893] = Fluid3D([11771,11733,11235,11158],0); -ELEMENTS[29894] = Fluid3D([11940,11733,12266,10987],0); -ELEMENTS[29895] = Fluid3D([11190,11733,11940,10987],0); -ELEMENTS[29896] = Fluid3D([9500,10216,9290,10209],0); -ELEMENTS[29897] = Fluid3D([10076,10495,10700,10990],0); -ELEMENTS[29898] = Fluid3D([10640,9854,10276,9593],0); -ELEMENTS[29899] = Fluid3D([18374,18378,18297,18470],0); -ELEMENTS[29900] = Fluid3D([3688,4463,4129,3925],0); -ELEMENTS[29901] = Fluid3D([3688,4463,3925,3555],0); -ELEMENTS[29902] = Fluid3D([3925,3688,3555,3488],0); -ELEMENTS[29903] = Fluid3D([3555,3925,3488,3760],0); -ELEMENTS[29904] = Fluid3D([3688,3555,3488,3221],0); -ELEMENTS[29905] = Fluid3D([3555,3488,3221,3760],0); -ELEMENTS[29906] = Fluid3D([3925,3688,3488,3866],0); -ELEMENTS[29907] = Fluid3D([3488,3925,3866,3760],0); -ELEMENTS[29908] = Fluid3D([3925,3866,3760,4239],0); -ELEMENTS[29909] = Fluid3D([3925,3866,4239,4129],0); -ELEMENTS[29910] = Fluid3D([3925,3866,4129,3688],0); -ELEMENTS[29911] = Fluid3D([3866,4239,4129,4521],0); -ELEMENTS[29912] = Fluid3D([3866,4129,3688,3807],0); -ELEMENTS[29913] = Fluid3D([3866,4129,3807,4040],0); -ELEMENTS[29914] = Fluid3D([4129,3807,4040,4039],0); -ELEMENTS[29915] = Fluid3D([3807,4040,4039,3509],0); -ELEMENTS[29916] = Fluid3D([3807,4040,3509,3511],0); -ELEMENTS[29917] = Fluid3D([3807,4040,3511,3866],0); -ELEMENTS[29918] = Fluid3D([3509,3807,3511,3421],0); -ELEMENTS[29919] = Fluid3D([3511,3807,3866,3688],0); -ELEMENTS[29920] = Fluid3D([3866,3760,4239,4521],0); -ELEMENTS[29921] = Fluid3D([4129,3688,3807,4206],0); -ELEMENTS[29922] = Fluid3D([4463,4129,3925,4239],0); -ELEMENTS[29923] = Fluid3D([3509,3807,3421,3590],0); -ELEMENTS[29924] = Fluid3D([17999,18124,18192,18223],0); -ELEMENTS[29925] = Fluid3D([18192,17999,18223,18132],0); -ELEMENTS[29926] = Fluid3D([17999,18124,18223,18037],0); -ELEMENTS[29927] = Fluid3D([18124,18192,18223,18379],0); -ELEMENTS[29928] = Fluid3D([13495,12779,13399,13686],0); -ELEMENTS[29929] = Fluid3D([9093,9024,8219,8852],0); -ELEMENTS[29930] = Fluid3D([16493,16745,17006,16695],0); -ELEMENTS[29931] = Fluid3D([13281,13431,13870,13036],0); -ELEMENTS[29932] = Fluid3D([15929,15867,15463,16120],0); -ELEMENTS[29933] = Fluid3D([15463,15929,16120,15812],0); -ELEMENTS[29934] = Fluid3D([15929,15867,16120,16502],0); -ELEMENTS[29935] = Fluid3D([15929,16120,15812,16308],0); -ELEMENTS[29936] = Fluid3D([15812,15929,16308,15800],0); -ELEMENTS[29937] = Fluid3D([15929,16308,15800,15702],0); -ELEMENTS[29938] = Fluid3D([15929,16120,16308,16502],0); -ELEMENTS[29939] = Fluid3D([16308,15929,16502,15997],0); -ELEMENTS[29940] = Fluid3D([15812,15929,15800,15116],0); -ELEMENTS[29941] = Fluid3D([15463,15929,15812,15116],0); -ELEMENTS[29942] = Fluid3D([16120,15463,15812,15656],0); -ELEMENTS[29943] = Fluid3D([15463,15812,15656,15282],0); -ELEMENTS[29944] = Fluid3D([16120,15463,15656,15691],0); -ELEMENTS[29945] = Fluid3D([15463,15656,15691,15073],0); -ELEMENTS[29946] = Fluid3D([15463,15656,15073,14864],0); -ELEMENTS[29947] = Fluid3D([15812,16120,15656,16090],0); -ELEMENTS[29948] = Fluid3D([15656,15691,15073,15495],0); -ELEMENTS[29949] = Fluid3D([15073,15656,15495,15132],0); -ELEMENTS[29950] = Fluid3D([15656,15495,15132,15752],0); -ELEMENTS[29951] = Fluid3D([15656,15691,15495,16049],0); -ELEMENTS[29952] = Fluid3D([15656,15691,16049,16120],0); -ELEMENTS[29953] = Fluid3D([15691,15495,16049,15891],0); -ELEMENTS[29954] = Fluid3D([16049,15691,15891,16265],0); -ELEMENTS[29955] = Fluid3D([16049,15691,16265,16120],0); -ELEMENTS[29956] = Fluid3D([15891,16049,16265,16621],0); -ELEMENTS[29957] = Fluid3D([15691,15495,15891,15419],0); -ELEMENTS[29958] = Fluid3D([15891,15691,15419,16265],0); -ELEMENTS[29959] = Fluid3D([15691,15495,15419,15073],0); -ELEMENTS[29960] = Fluid3D([15419,15691,15073,15234],0); -ELEMENTS[29961] = Fluid3D([15073,15656,15132,14864],0); -ELEMENTS[29962] = Fluid3D([15132,15073,14864,14229],0); -ELEMENTS[29963] = Fluid3D([15495,15656,16049,15752],0); -ELEMENTS[29964] = Fluid3D([15867,15463,16120,15691],0); -ELEMENTS[29965] = Fluid3D([15495,15073,15132,14793],0); -ELEMENTS[29966] = Fluid3D([15495,15073,14793,15419],0); -ELEMENTS[29967] = Fluid3D([15073,15132,14793,14229],0); -ELEMENTS[29968] = Fluid3D([15132,15495,14793,15225],0); -ELEMENTS[29969] = Fluid3D([15495,14793,15225,15226],0); -ELEMENTS[29970] = Fluid3D([15495,14793,15226,15419],0); -ELEMENTS[29971] = Fluid3D([14793,15225,15226,14635],0); -ELEMENTS[29972] = Fluid3D([14793,15225,14635,14571],0); -ELEMENTS[29973] = Fluid3D([15226,14793,14635,14072],0); -ELEMENTS[29974] = Fluid3D([15132,15495,15225,15752],0); -ELEMENTS[29975] = Fluid3D([14793,15225,14571,15132],0); -ELEMENTS[29976] = Fluid3D([14635,14793,14571,14072],0); -ELEMENTS[29977] = Fluid3D([15225,15226,14635,15287],0); -ELEMENTS[29978] = Fluid3D([15226,14635,15287,14888],0); -ELEMENTS[29979] = Fluid3D([14635,15287,14888,14647],0); -ELEMENTS[29980] = Fluid3D([14635,15287,14647,14853],0); -ELEMENTS[29981] = Fluid3D([14635,15287,14853,15225],0); -ELEMENTS[29982] = Fluid3D([15225,15226,15287,15804],0); -ELEMENTS[29983] = Fluid3D([15287,15225,15804,15723],0); -ELEMENTS[29984] = Fluid3D([15225,15226,15804,15495],0); -ELEMENTS[29985] = Fluid3D([15287,14647,14853,15397],0); -ELEMENTS[29986] = Fluid3D([15226,14635,14888,14072],0); -ELEMENTS[29987] = Fluid3D([15287,14888,14647,15242],0); -ELEMENTS[29988] = Fluid3D([14647,15287,15242,15397],0); -ELEMENTS[29989] = Fluid3D([15287,14888,15242,15593],0); -ELEMENTS[29990] = Fluid3D([14888,14647,15242,14544],0); -ELEMENTS[29991] = Fluid3D([14647,15242,14544,14659],0); -ELEMENTS[29992] = Fluid3D([14647,15242,14659,15397],0); -ELEMENTS[29993] = Fluid3D([14888,14647,14544,13642],0); -ELEMENTS[29994] = Fluid3D([14888,15242,15593,15440],0); -ELEMENTS[29995] = Fluid3D([15226,15287,15804,15593],0); -ELEMENTS[29996] = Fluid3D([15287,14888,15593,15226],0); -ELEMENTS[29997] = Fluid3D([15242,15287,15593,15781],0); -ELEMENTS[29998] = Fluid3D([15593,15242,15781,15440],0); -ELEMENTS[29999] = Fluid3D([15242,14544,14659,15288],0); -ELEMENTS[30000] = Fluid3D([15495,16049,15891,15804],0); -ELEMENTS[30001] = Fluid3D([15225,14635,14571,14853],0); -ELEMENTS[30002] = Fluid3D([14647,14635,14853,14057],0); -ELEMENTS[30003] = Fluid3D([14647,14635,14057,13642],0); -ELEMENTS[30004] = Fluid3D([14635,14853,14057,14571],0); -ELEMENTS[30005] = Fluid3D([14853,14647,14057,14412],0); -ELEMENTS[30006] = Fluid3D([14647,14057,14412,13400],0); -ELEMENTS[30007] = Fluid3D([14057,14853,14412,14239],0); -ELEMENTS[30008] = Fluid3D([14853,14647,14412,15397],0); -ELEMENTS[30009] = Fluid3D([15691,15463,15073,15234],0); -ELEMENTS[30010] = Fluid3D([14888,14635,14647,13642],0); -ELEMENTS[30011] = Fluid3D([14544,14647,14659,13982],0); -ELEMENTS[30012] = Fluid3D([14544,14647,13982,13642],0); -ELEMENTS[30013] = Fluid3D([14647,14659,13982,14412],0); -ELEMENTS[30014] = Fluid3D([14659,14544,13982,14243],0); -ELEMENTS[30015] = Fluid3D([13982,14659,14243,14129],0); -ELEMENTS[30016] = Fluid3D([13982,14659,14129,14412],0); -ELEMENTS[30017] = Fluid3D([14243,13982,14129,13491],0); -ELEMENTS[30018] = Fluid3D([14659,14544,14243,15288],0); -ELEMENTS[30019] = Fluid3D([14544,13982,14243,13461],0); -ELEMENTS[30020] = Fluid3D([14659,14243,14129,14771],0); -ELEMENTS[30021] = Fluid3D([14129,14659,14771,15040],0); -ELEMENTS[30022] = Fluid3D([14659,14243,14771,15176],0); -ELEMENTS[30023] = Fluid3D([14243,14129,14771,13962],0); -ELEMENTS[30024] = Fluid3D([15242,14888,14544,15440],0); -ELEMENTS[30025] = Fluid3D([14474,14427,14112,15028],0); -ELEMENTS[30026] = Fluid3D([2953,2793,2598,2770],0); -ELEMENTS[30027] = Fluid3D([16713,17046,16667,16650],0); -ELEMENTS[30028] = Fluid3D([2859,2649,2825,3041],0); -ELEMENTS[30029] = Fluid3D([2825,2859,3041,3163],0); -ELEMENTS[30030] = Fluid3D([2649,2825,3041,2988],0); -ELEMENTS[30031] = Fluid3D([3041,2825,3163,3239],0); -ELEMENTS[30032] = Fluid3D([11159,10531,10673,11020],0); -ELEMENTS[30033] = Fluid3D([10531,10673,11020,9464],0); -ELEMENTS[30034] = Fluid3D([16272,16668,16372,16426],0); -ELEMENTS[30035] = Fluid3D([12110,11391,11613,12167],0); -ELEMENTS[30036] = Fluid3D([11613,12110,12167,12816],0); -ELEMENTS[30037] = Fluid3D([11391,11613,12167,11547],0); -ELEMENTS[30038] = Fluid3D([12676,12069,11864,11745],0); -ELEMENTS[30039] = Fluid3D([15379,15085,15488,15802],0); -ELEMENTS[30040] = Fluid3D([7109,6556,6715,6471],0); -ELEMENTS[30041] = Fluid3D([8487,7916,7910,7595],0); -ELEMENTS[30042] = Fluid3D([14025,13433,14097,13101],0); -ELEMENTS[30043] = Fluid3D([3868,3719,3506,3320],0); -ELEMENTS[30044] = Fluid3D([9958,10426,10912,10660],0); -ELEMENTS[30045] = Fluid3D([9958,10426,10660,9533],0); -ELEMENTS[30046] = Fluid3D([10426,10912,10660,11369],0); -ELEMENTS[30047] = Fluid3D([10660,10426,11369,10597],0); -ELEMENTS[30048] = Fluid3D([10660,10426,10597,9533],0); -ELEMENTS[30049] = Fluid3D([10912,9958,10660,11168],0); -ELEMENTS[30050] = Fluid3D([10426,11369,10597,11072],0); -ELEMENTS[30051] = Fluid3D([10426,11369,11072,10912],0); -ELEMENTS[30052] = Fluid3D([11369,10597,11072,10853],0); -ELEMENTS[30053] = Fluid3D([16519,16309,16209,16610],0); -ELEMENTS[30054] = Fluid3D([16519,16309,16610,16974],0); -ELEMENTS[30055] = Fluid3D([16309,16209,16610,16277],0); -ELEMENTS[30056] = Fluid3D([16209,16519,16610,16625],0); -ELEMENTS[30057] = Fluid3D([6230,6770,6366,5950],0); -ELEMENTS[30058] = Fluid3D([12660,13704,12979,13345],0); -ELEMENTS[30059] = Fluid3D([13704,12979,13345,13876],0); -ELEMENTS[30060] = Fluid3D([12979,12660,13345,12438],0); -ELEMENTS[30061] = Fluid3D([12660,13345,12438,13046],0); -ELEMENTS[30062] = Fluid3D([13345,12438,13046,12647],0); -ELEMENTS[30063] = Fluid3D([12438,12660,13046,12738],0); -ELEMENTS[30064] = Fluid3D([12660,13345,13046,13898],0); -ELEMENTS[30065] = Fluid3D([12660,13704,13345,13898],0); -ELEMENTS[30066] = Fluid3D([16452,16760,16969,16740],0); -ELEMENTS[30067] = Fluid3D([16969,16452,16740,16597],0); -ELEMENTS[30068] = Fluid3D([16452,16760,16740,16029],0); -ELEMENTS[30069] = Fluid3D([16760,16969,16740,17098],0); -ELEMENTS[30070] = Fluid3D([16740,16760,17098,16842],0); -ELEMENTS[30071] = Fluid3D([16760,17098,16842,17085],0); -ELEMENTS[30072] = Fluid3D([17098,16842,17085,17210],0); -ELEMENTS[30073] = Fluid3D([16760,17098,17085,17199],0); -ELEMENTS[30074] = Fluid3D([17085,16760,17199,16864],0); -ELEMENTS[30075] = Fluid3D([16760,17098,17199,16969],0); -ELEMENTS[30076] = Fluid3D([17098,17085,17199,17420],0); -ELEMENTS[30077] = Fluid3D([17199,17098,17420,16969],0); -ELEMENTS[30078] = Fluid3D([17098,17420,16969,17109],0); -ELEMENTS[30079] = Fluid3D([17098,17085,17420,17364],0); -ELEMENTS[30080] = Fluid3D([17085,16760,16864,16422],0); -ELEMENTS[30081] = Fluid3D([17199,17085,16864,17329],0); -ELEMENTS[30082] = Fluid3D([17199,17085,17329,17420],0); -ELEMENTS[30083] = Fluid3D([17085,16864,17329,17021],0); -ELEMENTS[30084] = Fluid3D([17329,17085,17021,17269],0); -ELEMENTS[30085] = Fluid3D([17021,17329,17269,17165],0); -ELEMENTS[30086] = Fluid3D([17269,17021,17165,17003],0); -ELEMENTS[30087] = Fluid3D([17269,17021,17003,17061],0); -ELEMENTS[30088] = Fluid3D([17269,17021,17061,17085],0); -ELEMENTS[30089] = Fluid3D([17003,17269,17061,17305],0); -ELEMENTS[30090] = Fluid3D([17269,17061,17305,17364],0); -ELEMENTS[30091] = Fluid3D([17061,17003,17305,16859],0); -ELEMENTS[30092] = Fluid3D([17021,17003,17061,16691],0); -ELEMENTS[30093] = Fluid3D([17061,17021,16691,17085],0); -ELEMENTS[30094] = Fluid3D([17021,17329,17165,16864],0); -ELEMENTS[30095] = Fluid3D([17085,16864,17021,16422],0); -ELEMENTS[30096] = Fluid3D([16864,17199,17329,17212],0); -ELEMENTS[30097] = Fluid3D([17199,17329,17212,17592],0); -ELEMENTS[30098] = Fluid3D([16864,17199,17212,16728],0); -ELEMENTS[30099] = Fluid3D([17098,16740,16842,17210],0); -ELEMENTS[30100] = Fluid3D([16969,16740,17098,17109],0); -ELEMENTS[30101] = Fluid3D([16760,17199,16864,16728],0); -ELEMENTS[30102] = Fluid3D([16842,16760,17085,16422],0); -ELEMENTS[30103] = Fluid3D([16740,16760,16842,16029],0); -ELEMENTS[30104] = Fluid3D([14720,14992,14983,15607],0); -ELEMENTS[30105] = Fluid3D([14624,15085,15308,14829],0); -ELEMENTS[30106] = Fluid3D([15085,15308,14829,15626],0); -ELEMENTS[30107] = Fluid3D([15308,14624,14829,14798],0); -ELEMENTS[30108] = Fluid3D([14829,15308,14798,15398],0); -ELEMENTS[30109] = Fluid3D([14624,14829,14798,14263],0); -ELEMENTS[30110] = Fluid3D([14624,14829,14263,14394],0); -ELEMENTS[30111] = Fluid3D([14829,14263,14394,14671],0); -ELEMENTS[30112] = Fluid3D([14829,14263,14671,14416],0); -ELEMENTS[30113] = Fluid3D([14829,14263,14416,14798],0); -ELEMENTS[30114] = Fluid3D([14263,14394,14671,13639],0); -ELEMENTS[30115] = Fluid3D([14263,14394,13639,13701],0); -ELEMENTS[30116] = Fluid3D([14671,14263,13639,13708],0); -ELEMENTS[30117] = Fluid3D([14263,14624,14394,13701],0); -ELEMENTS[30118] = Fluid3D([14671,14829,14416,15172],0); -ELEMENTS[30119] = Fluid3D([14829,14416,15172,15398],0); -ELEMENTS[30120] = Fluid3D([15172,14829,15398,15626],0); -ELEMENTS[30121] = Fluid3D([14394,14671,13639,14294],0); -ELEMENTS[30122] = Fluid3D([14263,13639,13708,13413],0); -ELEMENTS[30123] = Fluid3D([14263,14671,14416,13708],0); -ELEMENTS[30124] = Fluid3D([15308,14624,14798,14962],0); -ELEMENTS[30125] = Fluid3D([14416,14829,14798,15398],0); -ELEMENTS[30126] = Fluid3D([14263,13639,13413,13701],0); -ELEMENTS[30127] = Fluid3D([14829,15308,15398,15626],0); -ELEMENTS[30128] = Fluid3D([14624,15085,14829,14394],0); -ELEMENTS[30129] = Fluid3D([14671,14829,15172,15041],0); -ELEMENTS[30130] = Fluid3D([14467,14896,15071,15202],0); -ELEMENTS[30131] = Fluid3D([14467,14896,15202,14907],0); -ELEMENTS[30132] = Fluid3D([14896,15202,14907,15573],0); -ELEMENTS[30133] = Fluid3D([14896,15071,15202,15573],0); -ELEMENTS[30134] = Fluid3D([15071,14467,15202,14789],0); -ELEMENTS[30135] = Fluid3D([6949,6194,6540,7213],0); -ELEMENTS[30136] = Fluid3D([9021,9104,9804,9934],0); -ELEMENTS[30137] = Fluid3D([1888,2081,1966,1972],0); -ELEMENTS[30138] = Fluid3D([9421,9107,9982,9779],0); -ELEMENTS[30139] = Fluid3D([16215,16102,16514,16035],0); -ELEMENTS[30140] = Fluid3D([9782,10080,9890,10727],0); -ELEMENTS[30141] = Fluid3D([9890,9782,10727,9795],0); -ELEMENTS[30142] = Fluid3D([10080,9890,10727,10704],0); -ELEMENTS[30143] = Fluid3D([10080,9890,10704,9725],0); -ELEMENTS[30144] = Fluid3D([10727,10080,10704,11004],0); -ELEMENTS[30145] = Fluid3D([9782,10080,10727,10772],0); -ELEMENTS[30146] = Fluid3D([9890,10727,10704,10869],0); -ELEMENTS[30147] = Fluid3D([9890,10727,10869,9795],0); -ELEMENTS[30148] = Fluid3D([10727,10704,10869,11781],0); -ELEMENTS[30149] = Fluid3D([10704,9890,10869,10195],0); -ELEMENTS[30150] = Fluid3D([10704,9890,10195,9725],0); -ELEMENTS[30151] = Fluid3D([9890,10869,10195,10013],0); -ELEMENTS[30152] = Fluid3D([10869,10704,10195,11307],0); -ELEMENTS[30153] = Fluid3D([9529,9142,9481,10116],0); -ELEMENTS[30154] = Fluid3D([14716,14581,14234,13949],0); -ELEMENTS[30155] = Fluid3D([14581,14234,13949,13741],0); -ELEMENTS[30156] = Fluid3D([15341,14916,14714,14454],0); -ELEMENTS[30157] = Fluid3D([17341,17484,17715,17673],0); -ELEMENTS[30158] = Fluid3D([3140,2844,3098,2869],0); -ELEMENTS[30159] = Fluid3D([3140,2844,2869,2699],0); -ELEMENTS[30160] = Fluid3D([2844,2869,2699,2454],0); -ELEMENTS[30161] = Fluid3D([3098,3140,2869,3458],0); -ELEMENTS[30162] = Fluid3D([2844,3098,2869,2734],0); -ELEMENTS[30163] = Fluid3D([3098,2869,2734,3065],0); -ELEMENTS[30164] = Fluid3D([2869,2734,3065,2676],0); -ELEMENTS[30165] = Fluid3D([2869,2734,2676,2454],0); -ELEMENTS[30166] = Fluid3D([2734,3098,3065,3080],0); -ELEMENTS[30167] = Fluid3D([2734,3098,3080,2648],0); -ELEMENTS[30168] = Fluid3D([3098,2869,3065,3458],0); -ELEMENTS[30169] = Fluid3D([13484,13298,14157,13716],0); -ELEMENTS[30170] = Fluid3D([5752,5733,5409,6034],0); -ELEMENTS[30171] = Fluid3D([8586,7907,7929,7723],0); -ELEMENTS[30172] = Fluid3D([17546,17590,17309,17255],0); -ELEMENTS[30173] = Fluid3D([17309,17546,17255,17216],0); -ELEMENTS[30174] = Fluid3D([17546,17590,17255,17623],0); -ELEMENTS[30175] = Fluid3D([17590,17255,17623,17354],0); -ELEMENTS[30176] = Fluid3D([17546,17255,17216,17623],0); -ELEMENTS[30177] = Fluid3D([17546,17590,17623,17874],0); -ELEMENTS[30178] = Fluid3D([17590,17309,17255,17264],0); -ELEMENTS[30179] = Fluid3D([17590,17309,17264,17564],0); -ELEMENTS[30180] = Fluid3D([17255,17590,17264,17354],0); -ELEMENTS[30181] = Fluid3D([7490,6768,7030,7076],0); -ELEMENTS[30182] = Fluid3D([13340,14134,14030,13401],0); -ELEMENTS[30183] = Fluid3D([14708,14109,14201,13895],0); -ELEMENTS[30184] = Fluid3D([5940,6243,5628,6227],0); -ELEMENTS[30185] = Fluid3D([6243,5628,6227,5732],0); -ELEMENTS[30186] = Fluid3D([9086,9901,9551,9053],0); -ELEMENTS[30187] = Fluid3D([9551,9086,9053,8542],0); -ELEMENTS[30188] = Fluid3D([9901,9551,9053,9203],0); -ELEMENTS[30189] = Fluid3D([9551,9053,9203,8542],0); -ELEMENTS[30190] = Fluid3D([9053,9203,8542,8764],0); -ELEMENTS[30191] = Fluid3D([9053,9203,8764,9901],0); -ELEMENTS[30192] = Fluid3D([9086,9901,9053,9259],0); -ELEMENTS[30193] = Fluid3D([11285,12553,11987,11955],0); -ELEMENTS[30194] = Fluid3D([12553,11987,11955,13004],0); -ELEMENTS[30195] = Fluid3D([11285,12553,11955,12217],0); -ELEMENTS[30196] = Fluid3D([11987,11285,11955,10905],0); -ELEMENTS[30197] = Fluid3D([11955,11987,10905,12156],0); -ELEMENTS[30198] = Fluid3D([11285,11955,10905,11098],0); -ELEMENTS[30199] = Fluid3D([11285,11955,11098,12217],0); -ELEMENTS[30200] = Fluid3D([10905,11285,11098,10386],0); -ELEMENTS[30201] = Fluid3D([11987,11285,10905,11277],0); -ELEMENTS[30202] = Fluid3D([11955,10905,11098,11207],0); -ELEMENTS[30203] = Fluid3D([11955,10905,11207,12156],0); -ELEMENTS[30204] = Fluid3D([10425,11024,9999,10546],0); -ELEMENTS[30205] = Fluid3D([10425,11024,10546,11434],0); -ELEMENTS[30206] = Fluid3D([13566,13697,12987,13438],0); -ELEMENTS[30207] = Fluid3D([7692,7667,7972,6751],0); -ELEMENTS[30208] = Fluid3D([6261,6497,6131,6921],0); -ELEMENTS[30209] = Fluid3D([6497,6131,6921,6993],0); -ELEMENTS[30210] = Fluid3D([6131,6261,6921,6619],0); -ELEMENTS[30211] = Fluid3D([6261,6497,6921,7432],0); -ELEMENTS[30212] = Fluid3D([6497,6921,7432,6993],0); -ELEMENTS[30213] = Fluid3D([7152,7641,6898,7733],0); -ELEMENTS[30214] = Fluid3D([3469,3507,3890,3797],0); -ELEMENTS[30215] = Fluid3D([18278,18336,18103,18302],0); -ELEMENTS[30216] = Fluid3D([4720,5087,4893,4294],0); -ELEMENTS[30217] = Fluid3D([12517,11887,11620,11725],0); -ELEMENTS[30218] = Fluid3D([11887,11620,11725,10800],0); -ELEMENTS[30219] = Fluid3D([11620,12517,11725,12039],0); -ELEMENTS[30220] = Fluid3D([11620,12517,12039,12519],0); -ELEMENTS[30221] = Fluid3D([11725,11620,12039,11034],0); -ELEMENTS[30222] = Fluid3D([11725,11620,11034,10800],0); -ELEMENTS[30223] = Fluid3D([11620,12039,11034,11444],0); -ELEMENTS[30224] = Fluid3D([11034,11620,11444,10764],0); -ELEMENTS[30225] = Fluid3D([11620,12039,11444,12519],0); -ELEMENTS[30226] = Fluid3D([12517,11887,11725,12658],0); -ELEMENTS[30227] = Fluid3D([12517,11725,12039,12218],0); -ELEMENTS[30228] = Fluid3D([11725,12039,12218,11034],0); -ELEMENTS[30229] = Fluid3D([12161,11019,11349,11648],0); -ELEMENTS[30230] = Fluid3D([12161,11019,11648,11704],0); -ELEMENTS[30231] = Fluid3D([11349,12161,11648,12501],0); -ELEMENTS[30232] = Fluid3D([11349,12161,12501,12448],0); -ELEMENTS[30233] = Fluid3D([11648,11349,12501,11484],0); -ELEMENTS[30234] = Fluid3D([11349,12501,11484,12000],0); -ELEMENTS[30235] = Fluid3D([11019,11349,11648,10506],0); -ELEMENTS[30236] = Fluid3D([11648,11019,10506,11704],0); -ELEMENTS[30237] = Fluid3D([12161,11648,12501,11704],0); -ELEMENTS[30238] = Fluid3D([11648,11349,11484,10506],0); -ELEMENTS[30239] = Fluid3D([12501,11648,11484,11816],0); -ELEMENTS[30240] = Fluid3D([12501,11648,11816,11704],0); -ELEMENTS[30241] = Fluid3D([11648,11484,11816,10931],0); -ELEMENTS[30242] = Fluid3D([11648,11484,10931,10506],0); -ELEMENTS[30243] = Fluid3D([11484,11816,10931,11694],0); -ELEMENTS[30244] = Fluid3D([10931,11484,11694,10428],0); -ELEMENTS[30245] = Fluid3D([10931,11648,10506,11704],0); -ELEMENTS[30246] = Fluid3D([11816,11648,10931,11398],0); -ELEMENTS[30247] = Fluid3D([10931,11816,11398,11770],0); -ELEMENTS[30248] = Fluid3D([11816,10931,11694,11770],0); -ELEMENTS[30249] = Fluid3D([11484,11816,11694,12583],0); -ELEMENTS[30250] = Fluid3D([11484,12501,11816,12583],0); -ELEMENTS[30251] = Fluid3D([11484,12501,12583,12000],0); -ELEMENTS[30252] = Fluid3D([12817,13641,12878,13489],0); -ELEMENTS[30253] = Fluid3D([5603,5937,5282,6038],0); -ELEMENTS[30254] = Fluid3D([5397,5694,5704,5924],0); -ELEMENTS[30255] = Fluid3D([8430,7524,7950,8471],0); -ELEMENTS[30256] = Fluid3D([7950,8430,8471,8840],0); -ELEMENTS[30257] = Fluid3D([8547,8678,9475,9213],0); -ELEMENTS[30258] = Fluid3D([8678,9475,9213,10263],0); -ELEMENTS[30259] = Fluid3D([15061,14291,14604,14379],0); -ELEMENTS[30260] = Fluid3D([15439,15873,15700,16127],0); -ELEMENTS[30261] = Fluid3D([8739,9034,9502,8616],0); -ELEMENTS[30262] = Fluid3D([9034,9502,8616,9180],0); -ELEMENTS[30263] = Fluid3D([8616,9034,9180,8495],0); -ELEMENTS[30264] = Fluid3D([9034,9180,8495,9371],0); -ELEMENTS[30265] = Fluid3D([9034,9180,9371,10027],0); -ELEMENTS[30266] = Fluid3D([9180,8495,9371,9097],0); -ELEMENTS[30267] = Fluid3D([9502,8739,8616,9036],0); -ELEMENTS[30268] = Fluid3D([8739,9034,8616,7897],0); -ELEMENTS[30269] = Fluid3D([16486,16698,16176,16342],0); -ELEMENTS[30270] = Fluid3D([6386,5713,6180,6140],0); -ELEMENTS[30271] = Fluid3D([14419,14514,14461,15009],0); -ELEMENTS[30272] = Fluid3D([14419,14514,15009,15372],0); -ELEMENTS[30273] = Fluid3D([14461,14419,15009,14702],0); -ELEMENTS[30274] = Fluid3D([14514,14461,15009,15079],0); -ELEMENTS[30275] = Fluid3D([13930,12994,13841,13137],0); -ELEMENTS[30276] = Fluid3D([11177,10437,11446,11049],0); -ELEMENTS[30277] = Fluid3D([10437,11446,11049,10732],0); -ELEMENTS[30278] = Fluid3D([11177,10437,11049,10304],0); -ELEMENTS[30279] = Fluid3D([11446,11177,11049,12380],0); -ELEMENTS[30280] = Fluid3D([3956,4242,4425,3977],0); -ELEMENTS[30281] = Fluid3D([4425,3956,3977,3868],0); -ELEMENTS[30282] = Fluid3D([3956,4242,3977,3777],0); -ELEMENTS[30283] = Fluid3D([4242,4425,3977,4587],0); -ELEMENTS[30284] = Fluid3D([6766,7443,6619,6921],0); -ELEMENTS[30285] = Fluid3D([6619,6766,6921,6131],0); -ELEMENTS[30286] = Fluid3D([6766,6921,6131,6993],0); -ELEMENTS[30287] = Fluid3D([6766,7443,6921,7639],0); -ELEMENTS[30288] = Fluid3D([14685,15144,14880,14520],0); -ELEMENTS[30289] = Fluid3D([10432,10474,9935,9274],0); -ELEMENTS[30290] = Fluid3D([9953,10680,9857,9682],0); -ELEMENTS[30291] = Fluid3D([14338,14332,14596,13693],0); -ELEMENTS[30292] = Fluid3D([3069,2803,2760,2788],0); -ELEMENTS[30293] = Fluid3D([3069,2803,2788,3128],0); -ELEMENTS[30294] = Fluid3D([2760,3069,2788,3155],0); -ELEMENTS[30295] = Fluid3D([2803,2760,2788,2516],0); -ELEMENTS[30296] = Fluid3D([2788,2803,2516,2507],0); -ELEMENTS[30297] = Fluid3D([2803,2760,2516,2594],0); -ELEMENTS[30298] = Fluid3D([2803,2760,2594,2978],0); -ELEMENTS[30299] = Fluid3D([2516,2803,2594,2518],0); -ELEMENTS[30300] = Fluid3D([2516,2803,2518,2507],0); -ELEMENTS[30301] = Fluid3D([2803,2594,2518,2948],0); -ELEMENTS[30302] = Fluid3D([2760,2788,2516,2561],0); -ELEMENTS[30303] = Fluid3D([2760,2516,2594,2463],0); -ELEMENTS[30304] = Fluid3D([2594,2760,2463,2700],0); -ELEMENTS[30305] = Fluid3D([2760,2516,2463,2561],0); -ELEMENTS[30306] = Fluid3D([2463,2594,2700,2383],0); -ELEMENTS[30307] = Fluid3D([2516,2594,2463,2346],0); -ELEMENTS[30308] = Fluid3D([2594,2700,2383,2688],0); -ELEMENTS[30309] = Fluid3D([2594,2700,2688,2978],0); -ELEMENTS[30310] = Fluid3D([2594,2463,2346,2383],0); -ELEMENTS[30311] = Fluid3D([2516,2594,2346,2518],0); -ELEMENTS[30312] = Fluid3D([2700,2383,2688,2601],0); -ELEMENTS[30313] = Fluid3D([2700,2383,2601,2503],0); -ELEMENTS[30314] = Fluid3D([2383,2688,2601,2453],0); -ELEMENTS[30315] = Fluid3D([2383,2601,2503,2313],0); -ELEMENTS[30316] = Fluid3D([2383,2688,2453,2448],0); -ELEMENTS[30317] = Fluid3D([2383,2601,2313,2453],0); -ELEMENTS[30318] = Fluid3D([2453,2383,2448,2235],0); -ELEMENTS[30319] = Fluid3D([2448,2453,2235,2477],0); -ELEMENTS[30320] = Fluid3D([2383,2688,2448,2594],0); -ELEMENTS[30321] = Fluid3D([2688,2700,2601,2928],0); -ELEMENTS[30322] = Fluid3D([2688,2700,2928,2978],0); -ELEMENTS[30323] = Fluid3D([2700,2601,2928,2778],0); -ELEMENTS[30324] = Fluid3D([2700,2601,2778,2503],0); -ELEMENTS[30325] = Fluid3D([2601,2688,2928,2687],0); -ELEMENTS[30326] = Fluid3D([2601,2688,2687,2453],0); -ELEMENTS[30327] = Fluid3D([2687,2601,2453,2535],0); -ELEMENTS[30328] = Fluid3D([2688,2687,2453,2635],0); -ELEMENTS[30329] = Fluid3D([2687,2453,2635,2583],0); -ELEMENTS[30330] = Fluid3D([2453,2688,2635,2448],0); -ELEMENTS[30331] = Fluid3D([2601,2928,2778,2872],0); -ELEMENTS[30332] = Fluid3D([2700,2383,2503,2463],0); -ELEMENTS[30333] = Fluid3D([2928,2700,2778,3138],0); -ELEMENTS[30334] = Fluid3D([2503,2383,2313,2219],0); -ELEMENTS[30335] = Fluid3D([2503,2383,2219,2463],0); -ELEMENTS[30336] = Fluid3D([2383,2313,2219,2187],0); -ELEMENTS[30337] = Fluid3D([2383,2313,2187,2453],0); -ELEMENTS[30338] = Fluid3D([2219,2383,2187,2346],0); -ELEMENTS[30339] = Fluid3D([2313,2503,2219,2237],0); -ELEMENTS[30340] = Fluid3D([2503,2219,2237,2204],0); -ELEMENTS[30341] = Fluid3D([2313,2503,2237,2471],0); -ELEMENTS[30342] = Fluid3D([2503,2237,2471,2460],0); -ELEMENTS[30343] = Fluid3D([2503,2237,2460,2204],0); -ELEMENTS[30344] = Fluid3D([2219,2313,2237,2079],0); -ELEMENTS[30345] = Fluid3D([2237,2219,2079,2021],0); -ELEMENTS[30346] = Fluid3D([2219,2079,2021,2043],0); -ELEMENTS[30347] = Fluid3D([2313,2237,2079,2220],0); -ELEMENTS[30348] = Fluid3D([2313,2237,2220,2471],0); -ELEMENTS[30349] = Fluid3D([2237,2079,2220,1941],0); -ELEMENTS[30350] = Fluid3D([2219,2313,2079,2187],0); -ELEMENTS[30351] = Fluid3D([2313,2503,2471,2601],0); -ELEMENTS[30352] = Fluid3D([2237,2471,2460,2365],0); -ELEMENTS[30353] = Fluid3D([2760,2463,2700,2681],0); -ELEMENTS[30354] = Fluid3D([2760,2463,2681,2561],0); -ELEMENTS[30355] = Fluid3D([2700,2760,2681,3138],0); -ELEMENTS[30356] = Fluid3D([2463,2700,2681,2503],0); -ELEMENTS[30357] = Fluid3D([2463,2516,2346,2312],0); -ELEMENTS[30358] = Fluid3D([2079,2313,2220,2151],0); -ELEMENTS[30359] = Fluid3D([2313,2220,2151,2378],0); -ELEMENTS[30360] = Fluid3D([2079,2313,2151,2187],0); -ELEMENTS[30361] = Fluid3D([2220,2151,2378,2318],0); -ELEMENTS[30362] = Fluid3D([2378,2220,2318,2471],0); -ELEMENTS[30363] = Fluid3D([2220,2079,2151,2006],0); -ELEMENTS[30364] = Fluid3D([2151,2220,2006,2318],0); -ELEMENTS[30365] = Fluid3D([2220,2079,2006,1941],0); -ELEMENTS[30366] = Fluid3D([2079,2151,2006,1973],0); -ELEMENTS[30367] = Fluid3D([2151,2006,1973,2052],0); -ELEMENTS[30368] = Fluid3D([2006,2079,1973,1821],0); -ELEMENTS[30369] = Fluid3D([1973,2151,2052,2137],0); -ELEMENTS[30370] = Fluid3D([2151,2052,2137,2327],0); -ELEMENTS[30371] = Fluid3D([1973,2151,2137,2187],0); -ELEMENTS[30372] = Fluid3D([2151,2006,2052,2318],0); -ELEMENTS[30373] = Fluid3D([2079,2151,1973,2187],0); -ELEMENTS[30374] = Fluid3D([2151,2137,2187,2453],0); -ELEMENTS[30375] = Fluid3D([2006,1973,2052,1889],0); -ELEMENTS[30376] = Fluid3D([2006,1973,1889,1821],0); -ELEMENTS[30377] = Fluid3D([2052,2006,1889,2118],0); -ELEMENTS[30378] = Fluid3D([1889,2006,1821,1910],0); -ELEMENTS[30379] = Fluid3D([2313,2220,2378,2471],0); -ELEMENTS[30380] = Fluid3D([2151,2313,2378,2453],0); -ELEMENTS[30381] = Fluid3D([2594,2760,2700,2978],0); -ELEMENTS[30382] = Fluid3D([2471,2503,2460,2778],0); -ELEMENTS[30383] = Fluid3D([14974,15267,14787,15432],0); -ELEMENTS[30384] = Fluid3D([15267,14787,15432,14878],0); -ELEMENTS[30385] = Fluid3D([13185,13864,13077,13677],0); -ELEMENTS[30386] = Fluid3D([13185,13864,13677,14132],0); -ELEMENTS[30387] = Fluid3D([6875,6373,7069,6590],0); -ELEMENTS[30388] = Fluid3D([8095,7471,8389,7786],0); -ELEMENTS[30389] = Fluid3D([9629,10249,9837,8820],0); -ELEMENTS[30390] = Fluid3D([17602,17227,17303,17221],0); -ELEMENTS[30391] = Fluid3D([17227,17303,17221,16729],0); -ELEMENTS[30392] = Fluid3D([9287,8877,8347,9108],0); -ELEMENTS[30393] = Fluid3D([11875,10978,11168,11071],0); -ELEMENTS[30394] = Fluid3D([5003,4480,4977,4955],0); -ELEMENTS[30395] = Fluid3D([3176,3469,3036,3182],0); -ELEMENTS[30396] = Fluid3D([16041,16382,16145,15604],0); -ELEMENTS[30397] = Fluid3D([8832,8774,8411,8007],0); -ELEMENTS[30398] = Fluid3D([11972,12699,12234,12065],0); -ELEMENTS[30399] = Fluid3D([4258,4717,4327,4433],0); -ELEMENTS[30400] = Fluid3D([4717,4327,4433,4911],0); -ELEMENTS[30401] = Fluid3D([4327,4258,4433,4052],0); -ELEMENTS[30402] = Fluid3D([4433,4327,4052,4756],0); -ELEMENTS[30403] = Fluid3D([4258,4717,4433,4738],0); -ELEMENTS[30404] = Fluid3D([12879,13467,13711,13055],0); -ELEMENTS[30405] = Fluid3D([13467,13711,13055,14450],0); -ELEMENTS[30406] = Fluid3D([3141,2858,2963,3222],0); -ELEMENTS[30407] = Fluid3D([4391,3926,4319,4237],0); -ELEMENTS[30408] = Fluid3D([16576,16900,16729,16972],0); -ELEMENTS[30409] = Fluid3D([12050,11829,12467,11680],0); -ELEMENTS[30410] = Fluid3D([12085,12245,11897,12977],0); -ELEMENTS[30411] = Fluid3D([5892,5498,6164,5947],0); -ELEMENTS[30412] = Fluid3D([15049,14666,15124,15488],0); -ELEMENTS[30413] = Fluid3D([4368,4410,4890,4719],0); -ELEMENTS[30414] = Fluid3D([4890,4368,4719,4902],0); -ELEMENTS[30415] = Fluid3D([4368,4719,4902,4983],0); -ELEMENTS[30416] = Fluid3D([4719,4902,4983,5313],0); -ELEMENTS[30417] = Fluid3D([4719,4902,5313,4890],0); -ELEMENTS[30418] = Fluid3D([4890,4368,4902,4730],0); -ELEMENTS[30419] = Fluid3D([4983,4719,5313,5613],0); -ELEMENTS[30420] = Fluid3D([4902,4983,5313,5423],0); -ELEMENTS[30421] = Fluid3D([11997,12298,12763,12767],0); -ELEMENTS[30422] = Fluid3D([13704,13375,14108,13898],0); -ELEMENTS[30423] = Fluid3D([4473,4190,4731,4469],0); -ELEMENTS[30424] = Fluid3D([13310,13522,13075,12578],0); -ELEMENTS[30425] = Fluid3D([14066,13760,13668,14539],0); -ELEMENTS[30426] = Fluid3D([10215,10230,10896,9709],0); -ELEMENTS[30427] = Fluid3D([14058,13511,13626,14255],0); -ELEMENTS[30428] = Fluid3D([13626,14058,14255,14564],0); -ELEMENTS[30429] = Fluid3D([13511,13626,14255,13619],0); -ELEMENTS[30430] = Fluid3D([14058,13511,14255,14159],0); -ELEMENTS[30431] = Fluid3D([15900,15616,15550,15145],0); -ELEMENTS[30432] = Fluid3D([3591,3210,3314,3277],0); -ELEMENTS[30433] = Fluid3D([12619,13102,12560,12403],0); -ELEMENTS[30434] = Fluid3D([6248,7034,6947,6997],0); -ELEMENTS[30435] = Fluid3D([6964,7291,7112,6372],0); -ELEMENTS[30436] = Fluid3D([6964,7291,6372,6299],0); -ELEMENTS[30437] = Fluid3D([9035,8754,8246,8299],0); -ELEMENTS[30438] = Fluid3D([18269,18224,18264,17958],0); -ELEMENTS[30439] = Fluid3D([10690,9806,9943,10266],0); -ELEMENTS[30440] = Fluid3D([14607,13823,14466,14612],0); -ELEMENTS[30441] = Fluid3D([17946,17755,18057,18078],0); -ELEMENTS[30442] = Fluid3D([11040,10360,10066,9642],0); -ELEMENTS[30443] = Fluid3D([5978,5408,5924,5694],0); -ELEMENTS[30444] = Fluid3D([13873,13355,14192,13397],0); -ELEMENTS[30445] = Fluid3D([14505,13848,14610,14368],0); -ELEMENTS[30446] = Fluid3D([9484,10834,10248,10206],0); -ELEMENTS[30447] = Fluid3D([10248,9484,10206,9271],0); -ELEMENTS[30448] = Fluid3D([5318,5807,5854,5512],0); -ELEMENTS[30449] = Fluid3D([6014,5908,5448,5601],0); -ELEMENTS[30450] = Fluid3D([11062,10706,11149,10234],0); -ELEMENTS[30451] = Fluid3D([11062,10706,10234,10239],0); -ELEMENTS[30452] = Fluid3D([11149,11062,10234,10711],0); -ELEMENTS[30453] = Fluid3D([10706,11149,10234,9896],0); -ELEMENTS[30454] = Fluid3D([10234,10706,9896,9909],0); -ELEMENTS[30455] = Fluid3D([9896,10234,9909,9475],0); -ELEMENTS[30456] = Fluid3D([10234,10706,9909,10239],0); -ELEMENTS[30457] = Fluid3D([9909,10234,10239,9475],0); -ELEMENTS[30458] = Fluid3D([10706,9909,10239,10318],0); -ELEMENTS[30459] = Fluid3D([9909,10239,10318,9429],0); -ELEMENTS[30460] = Fluid3D([11149,10234,9896,10089],0); -ELEMENTS[30461] = Fluid3D([14234,15011,14707,14603],0); -ELEMENTS[30462] = Fluid3D([15537,16034,15316,16005],0); -ELEMENTS[30463] = Fluid3D([16034,15316,16005,16291],0); -ELEMENTS[30464] = Fluid3D([15537,16034,16005,16195],0); -ELEMENTS[30465] = Fluid3D([10637,10511,11233,11166],0); -ELEMENTS[30466] = Fluid3D([2665,2954,2666,2640],0); -ELEMENTS[30467] = Fluid3D([2954,2666,2640,2776],0); -ELEMENTS[30468] = Fluid3D([2666,2640,2776,2442],0); -ELEMENTS[30469] = Fluid3D([2640,2776,2442,2662],0); -ELEMENTS[30470] = Fluid3D([2640,2954,2776,3071],0); -ELEMENTS[30471] = Fluid3D([2640,2776,2662,2689],0); -ELEMENTS[30472] = Fluid3D([2640,2776,2689,3071],0); -ELEMENTS[30473] = Fluid3D([2662,2640,2689,2442],0); -ELEMENTS[30474] = Fluid3D([2640,2689,2442,2469],0); -ELEMENTS[30475] = Fluid3D([2640,2689,2469,2729],0); -ELEMENTS[30476] = Fluid3D([2442,2640,2469,2414],0); -ELEMENTS[30477] = Fluid3D([2954,2666,2776,2987],0); -ELEMENTS[30478] = Fluid3D([2665,2954,2640,2890],0); -ELEMENTS[30479] = Fluid3D([2665,2954,2890,3050],0); -ELEMENTS[30480] = Fluid3D([2640,2665,2890,2469],0); -ELEMENTS[30481] = Fluid3D([2954,2640,2890,3071],0); -ELEMENTS[30482] = Fluid3D([2666,2665,2640,2414],0); -ELEMENTS[30483] = Fluid3D([3252,3122,2920,3313],0); -ELEMENTS[30484] = Fluid3D([17549,17417,17363,17813],0); -ELEMENTS[30485] = Fluid3D([7604,8722,8152,7893],0); -ELEMENTS[30486] = Fluid3D([8152,7604,7893,7231],0); -ELEMENTS[30487] = Fluid3D([7893,8152,7231,8083],0); -ELEMENTS[30488] = Fluid3D([7893,8152,8083,8414],0); -ELEMENTS[30489] = Fluid3D([8722,8152,7893,8414],0); -ELEMENTS[30490] = Fluid3D([7858,8413,7258,8042],0); -ELEMENTS[30491] = Fluid3D([17438,17605,17491,17807],0); -ELEMENTS[30492] = Fluid3D([12524,13122,12180,12817],0); -ELEMENTS[30493] = Fluid3D([12304,11715,12552,12373],0); -ELEMENTS[30494] = Fluid3D([8019,8766,8658,8831],0); -ELEMENTS[30495] = Fluid3D([11089,10340,10104,10529],0); -ELEMENTS[30496] = Fluid3D([5514,5645,5131,5709],0); -ELEMENTS[30497] = Fluid3D([5514,5645,5709,6100],0); -ELEMENTS[30498] = Fluid3D([5645,5709,6100,5950],0); -ELEMENTS[30499] = Fluid3D([5709,6100,5950,5986],0); -ELEMENTS[30500] = Fluid3D([5709,6100,5986,5514],0); -ELEMENTS[30501] = Fluid3D([5950,5709,5986,5680],0); -ELEMENTS[30502] = Fluid3D([5709,5986,5680,5515],0); -ELEMENTS[30503] = Fluid3D([5709,5986,5515,5514],0); -ELEMENTS[30504] = Fluid3D([5680,5709,5515,5249],0); -ELEMENTS[30505] = Fluid3D([5950,5709,5680,5249],0); -ELEMENTS[30506] = Fluid3D([5986,5680,5515,6366],0); -ELEMENTS[30507] = Fluid3D([6100,5645,5950,6006],0); -ELEMENTS[30508] = Fluid3D([5131,5514,5709,5515],0); -ELEMENTS[30509] = Fluid3D([5645,5131,5709,5378],0); -ELEMENTS[30510] = Fluid3D([14152,14493,14956,14389],0); -ELEMENTS[30511] = Fluid3D([7272,6856,7193,6388],0); -ELEMENTS[30512] = Fluid3D([6856,7193,6388,6332],0); -ELEMENTS[30513] = Fluid3D([6146,6188,5657,5637],0); -ELEMENTS[30514] = Fluid3D([9181,8461,9236,9686],0); -ELEMENTS[30515] = Fluid3D([9236,9181,9686,9555],0); -ELEMENTS[30516] = Fluid3D([9181,8461,9686,8659],0); -ELEMENTS[30517] = Fluid3D([7218,7810,7308,7954],0); -ELEMENTS[30518] = Fluid3D([7218,7810,7954,7951],0); -ELEMENTS[30519] = Fluid3D([7810,7308,7954,8053],0); -ELEMENTS[30520] = Fluid3D([7810,7308,8053,7290],0); -ELEMENTS[30521] = Fluid3D([7954,7810,8053,8591],0); -ELEMENTS[30522] = Fluid3D([7308,7954,8053,8446],0); -ELEMENTS[30523] = Fluid3D([7308,7218,7954,7725],0); -ELEMENTS[30524] = Fluid3D([12546,12209,11713,11789],0); -ELEMENTS[30525] = Fluid3D([11713,12546,11789,12586],0); -ELEMENTS[30526] = Fluid3D([14854,15658,15407,15459],0); -ELEMENTS[30527] = Fluid3D([15658,15407,15459,16096],0); -ELEMENTS[30528] = Fluid3D([15407,15459,16096,15847],0); -ELEMENTS[30529] = Fluid3D([12247,11608,11324,12045],0); -ELEMENTS[30530] = Fluid3D([12247,11608,12045,12573],0); -ELEMENTS[30531] = Fluid3D([11324,12247,12045,12109],0); -ELEMENTS[30532] = Fluid3D([11324,12247,12109,11879],0); -ELEMENTS[30533] = Fluid3D([11608,12045,12573,12064],0); -ELEMENTS[30534] = Fluid3D([12573,11608,12064,12009],0); -ELEMENTS[30535] = Fluid3D([12573,11608,12009,12352],0); -ELEMENTS[30536] = Fluid3D([11608,12009,12352,11186],0); -ELEMENTS[30537] = Fluid3D([12009,12352,11186,12176],0); -ELEMENTS[30538] = Fluid3D([12009,12352,12176,13227],0); -ELEMENTS[30539] = Fluid3D([12009,12573,12352,12814],0); -ELEMENTS[30540] = Fluid3D([12009,12573,12814,12064],0); -ELEMENTS[30541] = Fluid3D([12573,12814,12064,12657],0); -ELEMENTS[30542] = Fluid3D([12352,12009,12814,13227],0); -ELEMENTS[30543] = Fluid3D([12045,12573,12064,12560],0); -ELEMENTS[30544] = Fluid3D([12045,12573,12560,13303],0); -ELEMENTS[30545] = Fluid3D([12064,12045,12560,11500],0); -ELEMENTS[30546] = Fluid3D([12064,12045,11500,11608],0); -ELEMENTS[30547] = Fluid3D([12045,11500,11608,11324],0); -ELEMENTS[30548] = Fluid3D([11500,12064,11608,10688],0); -ELEMENTS[30549] = Fluid3D([12045,11500,11324,11525],0); -ELEMENTS[30550] = Fluid3D([12045,11500,11525,12560],0); -ELEMENTS[30551] = Fluid3D([11525,12045,12560,12589],0); -ELEMENTS[30552] = Fluid3D([11500,11608,11324,10252],0); -ELEMENTS[30553] = Fluid3D([11608,12009,11186,11199],0); -ELEMENTS[30554] = Fluid3D([11608,12064,12009,11199],0); -ELEMENTS[30555] = Fluid3D([12247,12045,12109,13303],0); -ELEMENTS[30556] = Fluid3D([12247,11608,12573,12352],0); -ELEMENTS[30557] = Fluid3D([12045,12247,12573,13303],0); -ELEMENTS[30558] = Fluid3D([12045,11324,12109,11525],0); -ELEMENTS[30559] = Fluid3D([6169,6253,6264,6984],0); -ELEMENTS[30560] = Fluid3D([9001,9747,8822,9231],0); -ELEMENTS[30561] = Fluid3D([5418,5022,5476,5761],0); -ELEMENTS[30562] = Fluid3D([10635,11582,10709,10357],0); -ELEMENTS[30563] = Fluid3D([10709,10635,10357,9828],0); -ELEMENTS[30564] = Fluid3D([15815,15536,15517,15136],0); -ELEMENTS[30565] = Fluid3D([15536,15517,15136,15131],0); -ELEMENTS[30566] = Fluid3D([15517,15815,15136,15205],0); -ELEMENTS[30567] = Fluid3D([15815,15536,15136,15617],0); -ELEMENTS[30568] = Fluid3D([8532,8489,8742,9451],0); -ELEMENTS[30569] = Fluid3D([9584,10143,10429,10372],0); -ELEMENTS[30570] = Fluid3D([14849,14926,14262,14504],0); -ELEMENTS[30571] = Fluid3D([16119,15645,15567,15515],0); -ELEMENTS[30572] = Fluid3D([16172,16490,16509,16564],0); -ELEMENTS[30573] = Fluid3D([16509,16172,16564,15865],0); -ELEMENTS[30574] = Fluid3D([4765,4572,4340,4182],0); -ELEMENTS[30575] = Fluid3D([4572,4340,4182,3945],0); -ELEMENTS[30576] = Fluid3D([11562,12284,11520,11509],0); -ELEMENTS[30577] = Fluid3D([9376,8519,8723,9507],0); -ELEMENTS[30578] = Fluid3D([13901,14495,14741,13948],0); -ELEMENTS[30579] = Fluid3D([9570,10327,10373,10930],0); -ELEMENTS[30580] = Fluid3D([18020,18206,18215,18165],0); -ELEMENTS[30581] = Fluid3D([2372,2517,2269,2337],0); -ELEMENTS[30582] = Fluid3D([17624,17387,17428,17401],0); -ELEMENTS[30583] = Fluid3D([13419,13142,12665,13309],0); -ELEMENTS[30584] = Fluid3D([14215,14526,14382,14911],0); -ELEMENTS[30585] = Fluid3D([14382,14215,14911,14532],0); -ELEMENTS[30586] = Fluid3D([14526,14382,14911,14940],0); -ELEMENTS[30587] = Fluid3D([16141,15993,16537,16229],0); -ELEMENTS[30588] = Fluid3D([16885,16784,16469,16470],0); -ELEMENTS[30589] = Fluid3D([16784,16469,16470,16258],0); -ELEMENTS[30590] = Fluid3D([16885,16784,16470,16962],0); -ELEMENTS[30591] = Fluid3D([16469,16470,16258,15676],0); -ELEMENTS[30592] = Fluid3D([16469,16885,16470,16332],0); -ELEMENTS[30593] = Fluid3D([16784,16469,16258,16715],0); -ELEMENTS[30594] = Fluid3D([16470,16784,16258,16639],0); -ELEMENTS[30595] = Fluid3D([16400,16592,16922,16451],0); -ELEMENTS[30596] = Fluid3D([14781,15299,15480,15140],0); -ELEMENTS[30597] = Fluid3D([3794,4052,4193,4467],0); -ELEMENTS[30598] = Fluid3D([4319,4014,4536,4135],0); -ELEMENTS[30599] = Fluid3D([4536,4319,4135,4740],0); -ELEMENTS[30600] = Fluid3D([4135,4536,4740,4446],0); -ELEMENTS[30601] = Fluid3D([4536,4740,4446,4708],0); -ELEMENTS[30602] = Fluid3D([4135,4536,4446,4217],0); -ELEMENTS[30603] = Fluid3D([4536,4446,4217,4708],0); -ELEMENTS[30604] = Fluid3D([4446,4217,4708,4369],0); -ELEMENTS[30605] = Fluid3D([4446,4217,4369,3890],0); -ELEMENTS[30606] = Fluid3D([4217,4369,3890,4269],0); -ELEMENTS[30607] = Fluid3D([4014,4536,4135,4217],0); -ELEMENTS[30608] = Fluid3D([4014,4536,4217,4519],0); -ELEMENTS[30609] = Fluid3D([4536,4217,4519,4708],0); -ELEMENTS[30610] = Fluid3D([4319,4014,4135,3680],0); -ELEMENTS[30611] = Fluid3D([16713,16428,16865,16431],0); -ELEMENTS[30612] = Fluid3D([16713,16428,16431,16125],0); -ELEMENTS[30613] = Fluid3D([16428,16865,16431,16438],0); -ELEMENTS[30614] = Fluid3D([16428,16865,16438,16729],0); -ELEMENTS[30615] = Fluid3D([16431,16428,16438,15806],0); -ELEMENTS[30616] = Fluid3D([16865,16431,16438,16425],0); -ELEMENTS[30617] = Fluid3D([16865,16713,16431,16967],0); -ELEMENTS[30618] = Fluid3D([12085,11897,11483,12496],0); -ELEMENTS[30619] = Fluid3D([7007,7845,7587,7507],0); -ELEMENTS[30620] = Fluid3D([12107,12240,12919,12445],0); -ELEMENTS[30621] = Fluid3D([16272,16441,15775,16372],0); -ELEMENTS[30622] = Fluid3D([13764,12965,13700,13997],0); -ELEMENTS[30623] = Fluid3D([13700,13764,13997,14254],0); -ELEMENTS[30624] = Fluid3D([13764,12965,13997,13228],0); -ELEMENTS[30625] = Fluid3D([13764,13997,14254,14811],0); -ELEMENTS[30626] = Fluid3D([13997,13764,13228,14421],0); -ELEMENTS[30627] = Fluid3D([12965,13700,13997,13656],0); -ELEMENTS[30628] = Fluid3D([13700,13997,13656,13976],0); -ELEMENTS[30629] = Fluid3D([13656,13700,13976,13122],0); -ELEMENTS[30630] = Fluid3D([13976,13656,13122,13489],0); -ELEMENTS[30631] = Fluid3D([13656,13700,13122,12965],0); -ELEMENTS[30632] = Fluid3D([7699,8574,7917,7995],0); -ELEMENTS[30633] = Fluid3D([8629,8793,8487,9379],0); -ELEMENTS[30634] = Fluid3D([8629,8793,9379,9544],0); -ELEMENTS[30635] = Fluid3D([8793,8487,9379,9152],0); -ELEMENTS[30636] = Fluid3D([8793,8487,9152,7791],0); -ELEMENTS[30637] = Fluid3D([9379,8793,9152,9466],0); -ELEMENTS[30638] = Fluid3D([8487,8629,9379,9289],0); -ELEMENTS[30639] = Fluid3D([9379,8487,9289,9752],0); -ELEMENTS[30640] = Fluid3D([9289,9379,9752,10410],0); -ELEMENTS[30641] = Fluid3D([8487,9379,9152,9752],0); -ELEMENTS[30642] = Fluid3D([9379,9152,9752,9994],0); -ELEMENTS[30643] = Fluid3D([9152,9752,9994,10238],0); -ELEMENTS[30644] = Fluid3D([9379,9152,9994,9466],0); -ELEMENTS[30645] = Fluid3D([9152,9994,9466,9793],0); -ELEMENTS[30646] = Fluid3D([9994,9466,9793,10709],0); -ELEMENTS[30647] = Fluid3D([9152,9994,9793,10238],0); -ELEMENTS[30648] = Fluid3D([9793,9994,10709,10238],0); -ELEMENTS[30649] = Fluid3D([6397,6314,6411,5883],0); -ELEMENTS[30650] = Fluid3D([6314,6411,5883,6457],0); -ELEMENTS[30651] = Fluid3D([6411,5883,6457,6751],0); -ELEMENTS[30652] = Fluid3D([6411,5883,6751,6341],0); -ELEMENTS[30653] = Fluid3D([6751,6411,6341,6933],0); -ELEMENTS[30654] = Fluid3D([6751,6411,6933,7062],0); -ELEMENTS[30655] = Fluid3D([6751,6411,7062,6457],0); -ELEMENTS[30656] = Fluid3D([5883,6314,6457,5685],0); -ELEMENTS[30657] = Fluid3D([6411,5883,6341,6156],0); -ELEMENTS[30658] = Fluid3D([6411,6341,6933,6156],0); -ELEMENTS[30659] = Fluid3D([6341,6751,6933,7319],0); -ELEMENTS[30660] = Fluid3D([6751,6933,7319,7972],0); -ELEMENTS[30661] = Fluid3D([14725,14881,14480,15319],0); -ELEMENTS[30662] = Fluid3D([14480,14725,15319,14517],0); -ELEMENTS[30663] = Fluid3D([14725,15319,14517,15037],0); -ELEMENTS[30664] = Fluid3D([14725,15319,15037,15326],0); -ELEMENTS[30665] = Fluid3D([15319,14517,15037,15388],0); -ELEMENTS[30666] = Fluid3D([15037,15319,15388,15772],0); -ELEMENTS[30667] = Fluid3D([15037,15319,15772,15326],0); -ELEMENTS[30668] = Fluid3D([15319,15388,15772,15748],0); -ELEMENTS[30669] = Fluid3D([14517,14725,15037,14428],0); -ELEMENTS[30670] = Fluid3D([14725,15037,14428,15055],0); -ELEMENTS[30671] = Fluid3D([15319,15388,15748,15471],0); -ELEMENTS[30672] = Fluid3D([15388,15748,15471,15994],0); -ELEMENTS[30673] = Fluid3D([15471,15388,15994,15408],0); -ELEMENTS[30674] = Fluid3D([15471,15388,15408,14817],0); -ELEMENTS[30675] = Fluid3D([15388,15994,15408,15772],0); -ELEMENTS[30676] = Fluid3D([15388,15994,15772,15748],0); -ELEMENTS[30677] = Fluid3D([15471,15388,14817,14517],0); -ELEMENTS[30678] = Fluid3D([15388,15408,14817,14517],0); -ELEMENTS[30679] = Fluid3D([15772,15319,15748,16121],0); -ELEMENTS[30680] = Fluid3D([15748,15772,16121,15994],0); -ELEMENTS[30681] = Fluid3D([15772,16121,15994,16064],0); -ELEMENTS[30682] = Fluid3D([15319,14517,15388,15471],0); -ELEMENTS[30683] = Fluid3D([15388,15037,15772,15408],0); -ELEMENTS[30684] = Fluid3D([15037,14517,14428,14694],0); -ELEMENTS[30685] = Fluid3D([15388,15037,15408,14517],0); -ELEMENTS[30686] = Fluid3D([5654,5033,5605,5307],0); -ELEMENTS[30687] = Fluid3D([14492,13792,14510,14640],0); -ELEMENTS[30688] = Fluid3D([8309,8102,8351,7432],0); -ELEMENTS[30689] = Fluid3D([11832,10896,11604,11609],0); -ELEMENTS[30690] = Fluid3D([16728,16339,16463,16864],0); -ELEMENTS[30691] = Fluid3D([13919,14115,13793,14541],0); -ELEMENTS[30692] = Fluid3D([15996,16077,15813,15247],0); -ELEMENTS[30693] = Fluid3D([11885,12046,11148,11070],0); -ELEMENTS[30694] = Fluid3D([11148,11885,11070,11079],0); -ELEMENTS[30695] = Fluid3D([6194,6543,6442,7213],0); -ELEMENTS[30696] = Fluid3D([16498,16097,16266,16608],0); -ELEMENTS[30697] = Fluid3D([17275,17141,17536,17626],0); -ELEMENTS[30698] = Fluid3D([2223,2157,2185,1997],0); -ELEMENTS[30699] = Fluid3D([10852,11876,11488,11220],0); -ELEMENTS[30700] = Fluid3D([8566,9529,9464,9189],0); -ELEMENTS[30701] = Fluid3D([15053,15215,15713,15275],0); -ELEMENTS[30702] = Fluid3D([17504,17691,17858,17707],0); -ELEMENTS[30703] = Fluid3D([17858,17504,17707,17822],0); -ELEMENTS[30704] = Fluid3D([17666,17572,17377,17766],0); -ELEMENTS[30705] = Fluid3D([10494,11258,11033,10362],0); -ELEMENTS[30706] = Fluid3D([11258,11033,10362,11275],0); -ELEMENTS[30707] = Fluid3D([10494,11258,10362,9832],0); -ELEMENTS[30708] = Fluid3D([11033,10362,11275,10465],0); -ELEMENTS[30709] = Fluid3D([11033,10494,10362,9997],0); -ELEMENTS[30710] = Fluid3D([10494,10362,9997,9140],0); -ELEMENTS[30711] = Fluid3D([11033,10494,9997,10452],0); -ELEMENTS[30712] = Fluid3D([11258,11033,11275,12464],0); -ELEMENTS[30713] = Fluid3D([10362,11258,11275,10923],0); -ELEMENTS[30714] = Fluid3D([10362,11258,10923,9832],0); -ELEMENTS[30715] = Fluid3D([11258,11275,10923,11640],0); -ELEMENTS[30716] = Fluid3D([10923,11258,11640,10825],0); -ELEMENTS[30717] = Fluid3D([11640,10923,10825,10919],0); -ELEMENTS[30718] = Fluid3D([11640,10923,10919,11958],0); -ELEMENTS[30719] = Fluid3D([10923,10825,10919,9780],0); -ELEMENTS[30720] = Fluid3D([11275,10362,10923,10845],0); -ELEMENTS[30721] = Fluid3D([10362,11033,9997,9590],0); -ELEMENTS[30722] = Fluid3D([7484,7594,7943,6967],0); -ELEMENTS[30723] = Fluid3D([4012,3971,3597,3696],0); -ELEMENTS[30724] = Fluid3D([3499,3669,3458,3098],0); -ELEMENTS[30725] = Fluid3D([14821,14872,15076,15524],0); -ELEMENTS[30726] = Fluid3D([14872,15076,15524,15241],0); -ELEMENTS[30727] = Fluid3D([4968,4548,4603,5077],0); -ELEMENTS[30728] = Fluid3D([17383,17184,16915,17268],0); -ELEMENTS[30729] = Fluid3D([17383,17184,17268,17660],0); -ELEMENTS[30730] = Fluid3D([17184,16915,17268,16941],0); -ELEMENTS[30731] = Fluid3D([17184,16915,16941,16699],0); -ELEMENTS[30732] = Fluid3D([17268,17184,16941,17425],0); -ELEMENTS[30733] = Fluid3D([16915,17268,16941,16951],0); -ELEMENTS[30734] = Fluid3D([16941,17268,17425,17351],0); -ELEMENTS[30735] = Fluid3D([17425,16941,17351,16975],0); -ELEMENTS[30736] = Fluid3D([17425,16941,16975,17184],0); -ELEMENTS[30737] = Fluid3D([16941,16975,17184,16699],0); -ELEMENTS[30738] = Fluid3D([16941,17351,16975,16951],0); -ELEMENTS[30739] = Fluid3D([16941,16975,16699,16471],0); -ELEMENTS[30740] = Fluid3D([16941,16975,16471,16656],0); -ELEMENTS[30741] = Fluid3D([17351,17425,16975,17346],0); -ELEMENTS[30742] = Fluid3D([17351,17425,17346,17669],0); -ELEMENTS[30743] = Fluid3D([17351,17425,17669,17662],0); -ELEMENTS[30744] = Fluid3D([17268,17425,17351,17662],0); -ELEMENTS[30745] = Fluid3D([17425,16975,17346,17426],0); -ELEMENTS[30746] = Fluid3D([17346,17425,17426,17669],0); -ELEMENTS[30747] = Fluid3D([17425,16975,17426,17184],0); -ELEMENTS[30748] = Fluid3D([17426,17425,17184,17660],0); -ELEMENTS[30749] = Fluid3D([17425,17426,17669,17767],0); -ELEMENTS[30750] = Fluid3D([17425,17426,17767,17660],0); -ELEMENTS[30751] = Fluid3D([16975,17346,17426,17156],0); -ELEMENTS[30752] = Fluid3D([17346,17426,17156,17577],0); -ELEMENTS[30753] = Fluid3D([17156,17346,17577,17295],0); -ELEMENTS[30754] = Fluid3D([16975,17346,17156,16932],0); -ELEMENTS[30755] = Fluid3D([17156,17346,17295,16932],0); -ELEMENTS[30756] = Fluid3D([17346,17426,17577,17669],0); -ELEMENTS[30757] = Fluid3D([17268,17184,17425,17660],0); -ELEMENTS[30758] = Fluid3D([16915,17383,17268,17177],0); -ELEMENTS[30759] = Fluid3D([11944,11652,11240,11891],0); -ELEMENTS[30760] = Fluid3D([11652,11240,11891,10818],0); -ELEMENTS[30761] = Fluid3D([11240,11944,11891,12156],0); -ELEMENTS[30762] = Fluid3D([11891,11240,12156,11207],0); -ELEMENTS[30763] = Fluid3D([11374,11946,11084,11892],0); -ELEMENTS[30764] = Fluid3D([11946,11084,11892,12112],0); -ELEMENTS[30765] = Fluid3D([9633,10121,9201,9336],0); -ELEMENTS[30766] = Fluid3D([9201,9633,9336,8669],0); -ELEMENTS[30767] = Fluid3D([9633,10121,9336,10313],0); -ELEMENTS[30768] = Fluid3D([9633,9336,8669,9093],0); -ELEMENTS[30769] = Fluid3D([9336,9201,8669,8520],0); -ELEMENTS[30770] = Fluid3D([9336,9201,8520,9105],0); -ELEMENTS[30771] = Fluid3D([9201,8669,8520,8043],0); -ELEMENTS[30772] = Fluid3D([8669,9336,8520,8365],0); -ELEMENTS[30773] = Fluid3D([10121,9201,9336,9105],0); -ELEMENTS[30774] = Fluid3D([9201,9633,8669,9361],0); -ELEMENTS[30775] = Fluid3D([14496,14381,13762,14462],0); -ELEMENTS[30776] = Fluid3D([9265,9118,9061,9468],0); -ELEMENTS[30777] = Fluid3D([9118,9061,9468,8650],0); -ELEMENTS[30778] = Fluid3D([9061,9468,8650,9185],0); -ELEMENTS[30779] = Fluid3D([9468,9118,8650,8851],0); -ELEMENTS[30780] = Fluid3D([9061,9265,9468,9959],0); -ELEMENTS[30781] = Fluid3D([9468,9061,9959,9893],0); -ELEMENTS[30782] = Fluid3D([9061,9265,9959,8820],0); -ELEMENTS[30783] = Fluid3D([9265,9118,9468,10002],0); -ELEMENTS[30784] = Fluid3D([9118,9468,10002,9993],0); -ELEMENTS[30785] = Fluid3D([9265,9118,10002,9905],0); -ELEMENTS[30786] = Fluid3D([8633,8314,8070,9231],0); -ELEMENTS[30787] = Fluid3D([8633,8314,9231,8917],0); -ELEMENTS[30788] = Fluid3D([8708,8603,9252,9402],0); -ELEMENTS[30789] = Fluid3D([3457,3625,3680,3955],0); -ELEMENTS[30790] = Fluid3D([16425,16786,16897,16967],0); -ELEMENTS[30791] = Fluid3D([10494,11496,10862,10452],0); -ELEMENTS[30792] = Fluid3D([6337,6923,6225,6810],0); -ELEMENTS[30793] = Fluid3D([6668,6102,6688,6431],0); -ELEMENTS[30794] = Fluid3D([17116,16998,16727,16560],0); -ELEMENTS[30795] = Fluid3D([13607,13745,14396,14174],0); -ELEMENTS[30796] = Fluid3D([11617,10870,10894,9971],0); -ELEMENTS[30797] = Fluid3D([4251,4655,4746,4195],0); -ELEMENTS[30798] = Fluid3D([3919,4185,4631,4165],0); -ELEMENTS[30799] = Fluid3D([4631,3919,4165,4613],0); -ELEMENTS[30800] = Fluid3D([8430,8840,9377,8471],0); -ELEMENTS[30801] = Fluid3D([7265,7419,8049,7390],0); -ELEMENTS[30802] = Fluid3D([7265,7419,7390,6641],0); -ELEMENTS[30803] = Fluid3D([8049,7265,7390,7568],0); -ELEMENTS[30804] = Fluid3D([7265,7390,7568,6770],0); -ELEMENTS[30805] = Fluid3D([7265,7390,6770,6366],0); -ELEMENTS[30806] = Fluid3D([7568,7265,6770,6709],0); -ELEMENTS[30807] = Fluid3D([7265,7390,6366,6641],0); -ELEMENTS[30808] = Fluid3D([7419,8049,7390,8098],0); -ELEMENTS[30809] = Fluid3D([7390,7419,8098,6982],0); -ELEMENTS[30810] = Fluid3D([7419,8049,8098,8194],0); -ELEMENTS[30811] = Fluid3D([8098,7419,8194,7757],0); -ELEMENTS[30812] = Fluid3D([8098,7419,7757,6982],0); -ELEMENTS[30813] = Fluid3D([7419,8194,7757,7461],0); -ELEMENTS[30814] = Fluid3D([8194,8098,7757,9102],0); -ELEMENTS[30815] = Fluid3D([7419,8049,8194,7376],0); -ELEMENTS[30816] = Fluid3D([14594,14041,14798,14416],0); -ELEMENTS[30817] = Fluid3D([13680,13657,13389,12843],0); -ELEMENTS[30818] = Fluid3D([17013,17126,17385,17277],0); -ELEMENTS[30819] = Fluid3D([14957,15522,15531,15150],0); -ELEMENTS[30820] = Fluid3D([14957,15522,15150,14645],0); -ELEMENTS[30821] = Fluid3D([15522,15531,15150,15562],0); -ELEMENTS[30822] = Fluid3D([15531,15150,15562,14783],0); -ELEMENTS[30823] = Fluid3D([15531,14957,15150,14783],0); -ELEMENTS[30824] = Fluid3D([5097,4518,4924,4727],0); -ELEMENTS[30825] = Fluid3D([6160,6464,6935,6954],0); -ELEMENTS[30826] = Fluid3D([6935,6160,6954,6912],0); -ELEMENTS[30827] = Fluid3D([10316,10437,10304,9139],0); -ELEMENTS[30828] = Fluid3D([8398,9175,8640,8804],0); -ELEMENTS[30829] = Fluid3D([15082,15092,14565,14171],0); -ELEMENTS[30830] = Fluid3D([9088,10118,9261,10479],0); -ELEMENTS[30831] = Fluid3D([7668,6824,7198,7225],0); -ELEMENTS[30832] = Fluid3D([15801,15153,15245,14914],0); -ELEMENTS[30833] = Fluid3D([9682,9953,9000,9857],0); -ELEMENTS[30834] = Fluid3D([14434,15267,14878,14787],0); -ELEMENTS[30835] = Fluid3D([17594,17951,17799,17631],0); -ELEMENTS[30836] = Fluid3D([3700,3290,3681,3565],0); -ELEMENTS[30837] = Fluid3D([6333,6755,5990,6250],0); -ELEMENTS[30838] = Fluid3D([10560,11184,10221,11308],0); -ELEMENTS[30839] = Fluid3D([14414,13846,14657,14531],0); -ELEMENTS[30840] = Fluid3D([17874,17546,17814,17623],0); -ELEMENTS[30841] = Fluid3D([16432,16095,15897,16038],0); -ELEMENTS[30842] = Fluid3D([4154,4107,3782,3826],0); -ELEMENTS[30843] = Fluid3D([3782,4154,3826,3885],0); -ELEMENTS[30844] = Fluid3D([4154,3826,3885,4326],0); -ELEMENTS[30845] = Fluid3D([4107,3782,3826,3699],0); -ELEMENTS[30846] = Fluid3D([4154,4107,3826,4639],0); -ELEMENTS[30847] = Fluid3D([11120,11575,12059,11196],0); -ELEMENTS[30848] = Fluid3D([16254,16229,16543,16606],0); -ELEMENTS[30849] = Fluid3D([5172,5053,5715,5231],0); -ELEMENTS[30850] = Fluid3D([17223,17308,17597,17390],0); -ELEMENTS[30851] = Fluid3D([12603,12570,11787,12204],0); -ELEMENTS[30852] = Fluid3D([5295,4879,5369,5251],0); -ELEMENTS[30853] = Fluid3D([4879,5369,5251,4880],0); -ELEMENTS[30854] = Fluid3D([5251,4879,4880,4536],0); -ELEMENTS[30855] = Fluid3D([4879,5369,4880,4690],0); -ELEMENTS[30856] = Fluid3D([4880,4879,4690,4362],0); -ELEMENTS[30857] = Fluid3D([4690,4880,4362,4860],0); -ELEMENTS[30858] = Fluid3D([4880,4879,4362,4536],0); -ELEMENTS[30859] = Fluid3D([5369,4880,4690,5443],0); -ELEMENTS[30860] = Fluid3D([16894,16583,17054,16863],0); -ELEMENTS[30861] = Fluid3D([10324,9833,10018,9205],0); -ELEMENTS[30862] = Fluid3D([7406,7785,7731,6614],0); -ELEMENTS[30863] = Fluid3D([11311,11012,11048,11986],0); -ELEMENTS[30864] = Fluid3D([18044,17875,18067,18200],0); -ELEMENTS[30865] = Fluid3D([18067,18044,18200,18280],0); -ELEMENTS[30866] = Fluid3D([8276,8746,8375,9428],0); -ELEMENTS[30867] = Fluid3D([12194,11301,11485,11902],0); -ELEMENTS[30868] = Fluid3D([14727,14428,14694,15037],0); -ELEMENTS[30869] = Fluid3D([6638,6047,6298,5842],0); -ELEMENTS[30870] = Fluid3D([6047,6298,5842,5555],0); -ELEMENTS[30871] = Fluid3D([14082,13411,14337,14119],0); -ELEMENTS[30872] = Fluid3D([14082,13411,14119,13572],0); -ELEMENTS[30873] = Fluid3D([14337,14082,14119,14761],0); -ELEMENTS[30874] = Fluid3D([14082,14119,14761,14298],0); -ELEMENTS[30875] = Fluid3D([13411,14337,14119,13770],0); -ELEMENTS[30876] = Fluid3D([14119,14082,13572,14298],0); -ELEMENTS[30877] = Fluid3D([14119,13411,13770,13434],0); -ELEMENTS[30878] = Fluid3D([13411,14119,13572,13434],0); -ELEMENTS[30879] = Fluid3D([4126,4534,4485,4486],0); -ELEMENTS[30880] = Fluid3D([9816,9469,9039,9882],0); -ELEMENTS[30881] = Fluid3D([12687,13318,12758,12023],0); -ELEMENTS[30882] = Fluid3D([16452,16636,16597,16969],0); -ELEMENTS[30883] = Fluid3D([17594,17335,17631,17799],0); -ELEMENTS[30884] = Fluid3D([16812,17207,17139,17347],0); -ELEMENTS[30885] = Fluid3D([12709,11923,11879,12100],0); -ELEMENTS[30886] = Fluid3D([11879,12709,12100,12639],0); -ELEMENTS[30887] = Fluid3D([12709,12100,12639,12918],0); -ELEMENTS[30888] = Fluid3D([12709,12100,12918,11923],0); -ELEMENTS[30889] = Fluid3D([11923,11879,12100,11089],0); -ELEMENTS[30890] = Fluid3D([11923,11879,11089,11148],0); -ELEMENTS[30891] = Fluid3D([9754,10051,9216,10659],0); -ELEMENTS[30892] = Fluid3D([5535,5883,5685,6314],0); -ELEMENTS[30893] = Fluid3D([14043,13799,13196,13626],0); -ELEMENTS[30894] = Fluid3D([4466,4795,4295,4343],0); -ELEMENTS[30895] = Fluid3D([14233,13534,14350,13731],0); -ELEMENTS[30896] = Fluid3D([14233,13534,13731,13079],0); -ELEMENTS[30897] = Fluid3D([13534,14350,13731,13282],0); -ELEMENTS[30898] = Fluid3D([14350,14233,13731,14527],0); -ELEMENTS[30899] = Fluid3D([14350,14233,14527,15257],0); -ELEMENTS[30900] = Fluid3D([13731,14350,14527,14632],0); -ELEMENTS[30901] = Fluid3D([14350,14527,14632,14927],0); -ELEMENTS[30902] = Fluid3D([14527,14632,14927,15257],0); -ELEMENTS[30903] = Fluid3D([14350,14527,14927,15257],0); -ELEMENTS[30904] = Fluid3D([14527,14632,15257,15125],0); -ELEMENTS[30905] = Fluid3D([14233,13731,14527,14340],0); -ELEMENTS[30906] = Fluid3D([14527,14233,14340,14876],0); -ELEMENTS[30907] = Fluid3D([14233,14340,14876,14806],0); -ELEMENTS[30908] = Fluid3D([14340,14527,14876,15125],0); -ELEMENTS[30909] = Fluid3D([14876,14340,15125,14611],0); -ELEMENTS[30910] = Fluid3D([14527,14876,15125,15257],0); -ELEMENTS[30911] = Fluid3D([14876,15125,15257,15720],0); -ELEMENTS[30912] = Fluid3D([14527,14876,15257,14233],0); -ELEMENTS[30913] = Fluid3D([15676,15292,15851,15885],0); -ELEMENTS[30914] = Fluid3D([15676,15292,15885,15239],0); -ELEMENTS[30915] = Fluid3D([15292,15851,15885,15641],0); -ELEMENTS[30916] = Fluid3D([15292,15851,15641,15034],0); -ELEMENTS[30917] = Fluid3D([15851,15676,15885,16470],0); -ELEMENTS[30918] = Fluid3D([16949,17273,17354,17264],0); -ELEMENTS[30919] = Fluid3D([13047,12141,12569,12623],0); -ELEMENTS[30920] = Fluid3D([5558,5811,5653,5122],0); -ELEMENTS[30921] = Fluid3D([8402,7701,7566,8143],0); -ELEMENTS[30922] = Fluid3D([7566,8402,8143,8497],0); -ELEMENTS[30923] = Fluid3D([8402,7701,8143,8466],0); -ELEMENTS[30924] = Fluid3D([8143,8402,8466,9145],0); -ELEMENTS[30925] = Fluid3D([8143,8402,9145,9238],0); -ELEMENTS[30926] = Fluid3D([8143,8402,9238,8497],0); -ELEMENTS[30927] = Fluid3D([12158,11909,11171,11520],0); -ELEMENTS[30928] = Fluid3D([8688,7741,8115,8311],0); -ELEMENTS[30929] = Fluid3D([8115,8688,8311,8790],0); -ELEMENTS[30930] = Fluid3D([8688,8311,8790,9471],0); -ELEMENTS[30931] = Fluid3D([8790,8688,9471,9085],0); -ELEMENTS[30932] = Fluid3D([9471,8790,9085,9495],0); -ELEMENTS[30933] = Fluid3D([8688,9471,9085,9480],0); -ELEMENTS[30934] = Fluid3D([8688,9471,9480,9045],0); -ELEMENTS[30935] = Fluid3D([9085,8688,9480,9543],0); -ELEMENTS[30936] = Fluid3D([8688,9480,9543,9903],0); -ELEMENTS[30937] = Fluid3D([9480,9543,9903,10088],0); -ELEMENTS[30938] = Fluid3D([9480,9543,10088,9800],0); -ELEMENTS[30939] = Fluid3D([9903,9480,10088,10579],0); -ELEMENTS[30940] = Fluid3D([9543,9903,10088,10534],0); -ELEMENTS[30941] = Fluid3D([9480,9543,9800,9085],0); -ELEMENTS[30942] = Fluid3D([10088,9480,9800,10579],0); -ELEMENTS[30943] = Fluid3D([9543,10088,9800,9128],0); -ELEMENTS[30944] = Fluid3D([9800,10088,10579,10058],0); -ELEMENTS[30945] = Fluid3D([9800,10088,10058,9128],0); -ELEMENTS[30946] = Fluid3D([10088,9903,10579,10534],0); -ELEMENTS[30947] = Fluid3D([10579,10088,10534,10058],0); -ELEMENTS[30948] = Fluid3D([10088,10534,10058,9543],0); -ELEMENTS[30949] = Fluid3D([9903,9480,10579,10218],0); -ELEMENTS[30950] = Fluid3D([9480,10579,10218,9471],0); -ELEMENTS[30951] = Fluid3D([9903,9480,10218,9471],0); -ELEMENTS[30952] = Fluid3D([9480,9800,10579,9471],0); -ELEMENTS[30953] = Fluid3D([9800,9480,9085,9471],0); -ELEMENTS[30954] = Fluid3D([10579,9903,10218,10970],0); -ELEMENTS[30955] = Fluid3D([9543,10088,9128,10058],0); -ELEMENTS[30956] = Fluid3D([9543,9800,9085,9128],0); -ELEMENTS[30957] = Fluid3D([9800,9085,9128,9103],0); -ELEMENTS[30958] = Fluid3D([10058,9800,9128,9103],0); -ELEMENTS[30959] = Fluid3D([4813,4592,5077,5100],0); -ELEMENTS[30960] = Fluid3D([12055,13076,12745,12128],0); -ELEMENTS[30961] = Fluid3D([10623,9429,10074,10318],0); -ELEMENTS[30962] = Fluid3D([10783,10114,10458,9633],0); -ELEMENTS[30963] = Fluid3D([13737,14186,14293,14863],0); -ELEMENTS[30964] = Fluid3D([8772,8851,8747,8022],0); -ELEMENTS[30965] = Fluid3D([8747,8772,8022,8809],0); -ELEMENTS[30966] = Fluid3D([8747,8772,8809,9608],0); -ELEMENTS[30967] = Fluid3D([8772,8022,8809,7953],0); -ELEMENTS[30968] = Fluid3D([8022,8747,8809,7927],0); -ELEMENTS[30969] = Fluid3D([7073,7407,6615,7465],0); -ELEMENTS[30970] = Fluid3D([18188,18129,18234,18326],0); -ELEMENTS[30971] = Fluid3D([18188,18129,18326,18152],0); -ELEMENTS[30972] = Fluid3D([18129,18234,18326,18314],0); -ELEMENTS[30973] = Fluid3D([18234,18326,18314,18359],0); -ELEMENTS[30974] = Fluid3D([18314,18234,18359,18186],0); -ELEMENTS[30975] = Fluid3D([18234,18188,18326,18359],0); -ELEMENTS[30976] = Fluid3D([18129,18234,18314,18012],0); -ELEMENTS[30977] = Fluid3D([18234,18314,18012,18186],0); -ELEMENTS[30978] = Fluid3D([5612,5570,5166,5105],0); -ELEMENTS[30979] = Fluid3D([4221,3720,3883,4005],0); -ELEMENTS[30980] = Fluid3D([4221,3720,4005,3893],0); -ELEMENTS[30981] = Fluid3D([5928,5531,5863,6229],0); -ELEMENTS[30982] = Fluid3D([7362,7287,7231,6522],0); -ELEMENTS[30983] = Fluid3D([15686,15715,15115,15141],0); -ELEMENTS[30984] = Fluid3D([13332,14027,13715,14513],0); -ELEMENTS[30985] = Fluid3D([16909,17231,16872,17235],0); -ELEMENTS[30986] = Fluid3D([12731,12179,12118,11852],0); -ELEMENTS[30987] = Fluid3D([8891,9636,9690,9187],0); -ELEMENTS[30988] = Fluid3D([6763,7166,6571,7332],0); -ELEMENTS[30989] = Fluid3D([7166,6571,7332,7320],0); -ELEMENTS[30990] = Fluid3D([6571,6763,7332,7089],0); -ELEMENTS[30991] = Fluid3D([6763,7166,7332,7595],0); -ELEMENTS[30992] = Fluid3D([8052,7613,7250,7193],0); -ELEMENTS[30993] = Fluid3D([3655,3939,3401,3831],0); -ELEMENTS[30994] = Fluid3D([3939,3401,3831,3894],0); -ELEMENTS[30995] = Fluid3D([13752,13004,12997,12398],0); -ELEMENTS[30996] = Fluid3D([13004,12997,12398,12553],0); -ELEMENTS[30997] = Fluid3D([6431,6941,7222,6688],0); -ELEMENTS[30998] = Fluid3D([6011,5851,6329,5743],0); -ELEMENTS[30999] = Fluid3D([5851,6329,5743,6219],0); -ELEMENTS[31000] = Fluid3D([6011,5851,5743,5402],0); -ELEMENTS[31001] = Fluid3D([6329,6011,5743,6125],0); -ELEMENTS[31002] = Fluid3D([6329,6011,6125,6792],0); -ELEMENTS[31003] = Fluid3D([5743,6329,6125,5787],0); -ELEMENTS[31004] = Fluid3D([6125,5743,5787,5889],0); -ELEMENTS[31005] = Fluid3D([5787,6125,5889,6415],0); -ELEMENTS[31006] = Fluid3D([5787,6125,6415,6723],0); -ELEMENTS[31007] = Fluid3D([6125,6415,6723,6792],0); -ELEMENTS[31008] = Fluid3D([5787,6125,6723,6329],0); -ELEMENTS[31009] = Fluid3D([6125,5889,6415,6792],0); -ELEMENTS[31010] = Fluid3D([6415,5787,6723,6667],0); -ELEMENTS[31011] = Fluid3D([6415,5787,6667,6192],0); -ELEMENTS[31012] = Fluid3D([6011,5743,6125,5889],0); -ELEMENTS[31013] = Fluid3D([6125,6011,5889,6792],0); -ELEMENTS[31014] = Fluid3D([6011,5743,5889,5402],0); -ELEMENTS[31015] = Fluid3D([5889,6011,5402,5673],0); -ELEMENTS[31016] = Fluid3D([5889,6011,5673,6370],0); -ELEMENTS[31017] = Fluid3D([5889,6011,6370,6792],0); -ELEMENTS[31018] = Fluid3D([6415,5787,6192,5889],0); -ELEMENTS[31019] = Fluid3D([6192,6415,5889,6370],0); -ELEMENTS[31020] = Fluid3D([6192,6415,6370,7171],0); -ELEMENTS[31021] = Fluid3D([6192,6415,7171,6860],0); -ELEMENTS[31022] = Fluid3D([6192,6415,6860,6667],0); -ELEMENTS[31023] = Fluid3D([6415,6860,6667,7461],0); -ELEMENTS[31024] = Fluid3D([5889,6192,6370,6002],0); -ELEMENTS[31025] = Fluid3D([6192,6370,6002,6779],0); -ELEMENTS[31026] = Fluid3D([6370,5889,6002,5673],0); -ELEMENTS[31027] = Fluid3D([12014,12122,12016,11131],0); -ELEMENTS[31028] = Fluid3D([15241,15624,15888,15524],0); -ELEMENTS[31029] = Fluid3D([6624,6497,7337,6993],0); -ELEMENTS[31030] = Fluid3D([13574,14387,14165,14196],0); -ELEMENTS[31031] = Fluid3D([13574,14387,14196,13933],0); -ELEMENTS[31032] = Fluid3D([14387,14165,14196,14719],0); -ELEMENTS[31033] = Fluid3D([14165,14196,14719,13520],0); -ELEMENTS[31034] = Fluid3D([14165,13574,14196,13520],0); -ELEMENTS[31035] = Fluid3D([8917,8417,8804,7968],0); -ELEMENTS[31036] = Fluid3D([13375,12738,12894,13858],0); -ELEMENTS[31037] = Fluid3D([5761,5810,5251,5822],0); -ELEMENTS[31038] = Fluid3D([15144,15726,15526,15634],0); -ELEMENTS[31039] = Fluid3D([15144,15726,15634,15268],0); -ELEMENTS[31040] = Fluid3D([7914,7965,8506,7493],0); -ELEMENTS[31041] = Fluid3D([9717,9655,8844,9387],0); -ELEMENTS[31042] = Fluid3D([16415,16511,16810,16320],0); -ELEMENTS[31043] = Fluid3D([14193,13473,13677,14170],0); -ELEMENTS[31044] = Fluid3D([13677,14193,14170,14630],0); -ELEMENTS[31045] = Fluid3D([3432,3062,3233,3340],0); -ELEMENTS[31046] = Fluid3D([3233,3432,3340,3692],0); -ELEMENTS[31047] = Fluid3D([11068,10082,10470,9917],0); -ELEMENTS[31048] = Fluid3D([12428,12284,11509,12062],0); -ELEMENTS[31049] = Fluid3D([12428,12284,12062,13052],0); -ELEMENTS[31050] = Fluid3D([11509,12428,12062,12245],0); -ELEMENTS[31051] = Fluid3D([12428,12062,12245,12977],0); -ELEMENTS[31052] = Fluid3D([12245,12428,12977,13349],0); -ELEMENTS[31053] = Fluid3D([12284,11509,12062,11520],0); -ELEMENTS[31054] = Fluid3D([10015,10200,10337,10838],0); -ELEMENTS[31055] = Fluid3D([10337,10015,10838,10308],0); -ELEMENTS[31056] = Fluid3D([10015,10838,10308,10122],0); -ELEMENTS[31057] = Fluid3D([10015,10838,10122,10326],0); -ELEMENTS[31058] = Fluid3D([10308,10015,10122,9407],0); -ELEMENTS[31059] = Fluid3D([10308,10015,9407,9327],0); -ELEMENTS[31060] = Fluid3D([9407,10308,9327,9596],0); -ELEMENTS[31061] = Fluid3D([9327,9407,9596,8731],0); -ELEMENTS[31062] = Fluid3D([9327,9407,8731,8957],0); -ELEMENTS[31063] = Fluid3D([9327,9407,8957,10015],0); -ELEMENTS[31064] = Fluid3D([9596,9327,8731,9448],0); -ELEMENTS[31065] = Fluid3D([9407,9596,8731,9138],0); -ELEMENTS[31066] = Fluid3D([9407,8957,10015,9376],0); -ELEMENTS[31067] = Fluid3D([9596,8731,9138,8680],0); -ELEMENTS[31068] = Fluid3D([10015,10122,9407,9376],0); -ELEMENTS[31069] = Fluid3D([9407,9596,9138,9861],0); -ELEMENTS[31070] = Fluid3D([10838,10308,10122,10871],0); -ELEMENTS[31071] = Fluid3D([10015,10200,10838,10839],0); -ELEMENTS[31072] = Fluid3D([8731,9407,9138,8081],0); -ELEMENTS[31073] = Fluid3D([9407,10308,9596,9861],0); -ELEMENTS[31074] = Fluid3D([10308,10122,10871,9861],0); -ELEMENTS[31075] = Fluid3D([10122,10871,9861,10490],0); -ELEMENTS[31076] = Fluid3D([10122,10871,10490,11502],0); -ELEMENTS[31077] = Fluid3D([9861,10122,10490,9507],0); -ELEMENTS[31078] = Fluid3D([10337,10015,10308,9327],0); -ELEMENTS[31079] = Fluid3D([10122,10308,9407,9861],0); -ELEMENTS[31080] = Fluid3D([10308,9327,9596,10383],0); -ELEMENTS[31081] = Fluid3D([9596,10308,10383,10227],0); -ELEMENTS[31082] = Fluid3D([10383,9596,10227,9656],0); -ELEMENTS[31083] = Fluid3D([9407,8731,8957,8081],0); -ELEMENTS[31084] = Fluid3D([17752,17759,17875,17532],0); -ELEMENTS[31085] = Fluid3D([13812,13245,13311,14128],0); -ELEMENTS[31086] = Fluid3D([8166,8497,7612,7566],0); -ELEMENTS[31087] = Fluid3D([4620,4840,4637,4132],0); -ELEMENTS[31088] = Fluid3D([17451,17719,17592,17269],0); -ELEMENTS[31089] = Fluid3D([11007,11240,10818,10358],0); -ELEMENTS[31090] = Fluid3D([11007,11240,10358,11280],0); -ELEMENTS[31091] = Fluid3D([11240,10818,10358,9919],0); -ELEMENTS[31092] = Fluid3D([10818,11007,10358,10057],0); -ELEMENTS[31093] = Fluid3D([8365,8406,9011,7966],0); -ELEMENTS[31094] = Fluid3D([17198,16833,16916,17129],0); -ELEMENTS[31095] = Fluid3D([14701,14979,15116,14397],0); -ELEMENTS[31096] = Fluid3D([14979,15116,14397,15164],0); -ELEMENTS[31097] = Fluid3D([14701,14979,14397,14361],0); -ELEMENTS[31098] = Fluid3D([15116,14701,14397,14713],0); -ELEMENTS[31099] = Fluid3D([15631,15254,15548,15910],0); -ELEMENTS[31100] = Fluid3D([13160,13785,13313,12730],0); -ELEMENTS[31101] = Fluid3D([3114,2854,2749,2835],0); -ELEMENTS[31102] = Fluid3D([3114,2854,2835,3244],0); -ELEMENTS[31103] = Fluid3D([2835,3114,3244,2976],0); -ELEMENTS[31104] = Fluid3D([2749,3114,2835,2976],0); -ELEMENTS[31105] = Fluid3D([2854,2749,2835,2381],0); -ELEMENTS[31106] = Fluid3D([2935,2949,2618,2952],0); -ELEMENTS[31107] = Fluid3D([2935,2949,2952,3260],0); -ELEMENTS[31108] = Fluid3D([2949,2618,2952,2673],0); -ELEMENTS[31109] = Fluid3D([2952,2949,2673,2999],0); -ELEMENTS[31110] = Fluid3D([2952,2949,2999,3172],0); -ELEMENTS[31111] = Fluid3D([2949,2673,2999,2910],0); -ELEMENTS[31112] = Fluid3D([2673,2952,2999,3081],0); -ELEMENTS[31113] = Fluid3D([2952,2999,3081,3281],0); -ELEMENTS[31114] = Fluid3D([2999,3081,3281,3133],0); -ELEMENTS[31115] = Fluid3D([3281,2999,3133,2910],0); -ELEMENTS[31116] = Fluid3D([2999,3081,3133,2827],0); -ELEMENTS[31117] = Fluid3D([2999,3081,2827,2673],0); -ELEMENTS[31118] = Fluid3D([3133,2999,2827,2820],0); -ELEMENTS[31119] = Fluid3D([2827,2999,2673,2532],0); -ELEMENTS[31120] = Fluid3D([2673,2827,2532,2514],0); -ELEMENTS[31121] = Fluid3D([2532,2673,2514,2365],0); -ELEMENTS[31122] = Fluid3D([2673,2952,3081,2744],0); -ELEMENTS[31123] = Fluid3D([2952,3081,2744,3088],0); -ELEMENTS[31124] = Fluid3D([2952,3081,3088,3260],0); -ELEMENTS[31125] = Fluid3D([2744,2952,3088,2741],0); -ELEMENTS[31126] = Fluid3D([2952,3088,2741,2935],0); -ELEMENTS[31127] = Fluid3D([3081,2744,3088,3206],0); -ELEMENTS[31128] = Fluid3D([2952,3088,2935,3260],0); -ELEMENTS[31129] = Fluid3D([3088,2744,2741,3060],0); -ELEMENTS[31130] = Fluid3D([2741,2952,2935,2618],0); -ELEMENTS[31131] = Fluid3D([2935,2741,2618,2651],0); -ELEMENTS[31132] = Fluid3D([2741,2618,2651,2403],0); -ELEMENTS[31133] = Fluid3D([2741,2618,2403,2365],0); -ELEMENTS[31134] = Fluid3D([2744,2952,2741,2618],0); -ELEMENTS[31135] = Fluid3D([2935,2741,2651,2956],0); -ELEMENTS[31136] = Fluid3D([2935,2741,2956,3088],0); -ELEMENTS[31137] = Fluid3D([2651,2741,2403,2675],0); -ELEMENTS[31138] = Fluid3D([2741,2651,2956,2675],0); -ELEMENTS[31139] = Fluid3D([2956,2741,2675,2864],0); -ELEMENTS[31140] = Fluid3D([2673,2952,2744,2618],0); -ELEMENTS[31141] = Fluid3D([2741,2403,2675,2460],0); -ELEMENTS[31142] = Fluid3D([2675,2956,2864,2944],0); -ELEMENTS[31143] = Fluid3D([2618,2651,2403,2401],0); -ELEMENTS[31144] = Fluid3D([2956,2741,2864,3060],0); -ELEMENTS[31145] = Fluid3D([2403,2618,2401,2365],0); -ELEMENTS[31146] = Fluid3D([2673,2827,2514,2744],0); -ELEMENTS[31147] = Fluid3D([2741,2675,2864,2460],0); -ELEMENTS[31148] = Fluid3D([2651,2956,2675,2595],0); -ELEMENTS[31149] = Fluid3D([2618,2651,2401,2793],0); -ELEMENTS[31150] = Fluid3D([2949,2618,2673,2598],0); -ELEMENTS[31151] = Fluid3D([2618,2935,2651,2793],0); -ELEMENTS[31152] = Fluid3D([2651,2935,2956,3026],0); -ELEMENTS[31153] = Fluid3D([2935,2956,3026,3273],0); -ELEMENTS[31154] = Fluid3D([2999,2673,2532,2910],0); -ELEMENTS[31155] = Fluid3D([2651,2403,2401,2349],0); -ELEMENTS[31156] = Fluid3D([2956,2651,3026,2595],0); -ELEMENTS[31157] = Fluid3D([2952,2999,3281,3172],0); -ELEMENTS[31158] = Fluid3D([2999,3281,3172,2910],0); -ELEMENTS[31159] = Fluid3D([2403,2651,2675,2449],0); -ELEMENTS[31160] = Fluid3D([2675,2403,2449,2314],0); -ELEMENTS[31161] = Fluid3D([2651,2675,2449,2595],0); -ELEMENTS[31162] = Fluid3D([2651,2935,3026,2793],0); -ELEMENTS[31163] = Fluid3D([2401,2651,2349,2497],0); -ELEMENTS[31164] = Fluid3D([2514,2673,2744,2365],0); -ELEMENTS[31165] = Fluid3D([17379,16967,17333,17311],0); -ELEMENTS[31166] = Fluid3D([7496,7214,7853,6926],0); -ELEMENTS[31167] = Fluid3D([11012,10809,10087,10268],0); -ELEMENTS[31168] = Fluid3D([7109,7712,6879,6869],0); -ELEMENTS[31169] = Fluid3D([6879,7109,6869,6556],0); -ELEMENTS[31170] = Fluid3D([7712,6879,6869,7040],0); -ELEMENTS[31171] = Fluid3D([7109,7712,6869,7908],0); -ELEMENTS[31172] = Fluid3D([6879,6869,7040,6020],0); -ELEMENTS[31173] = Fluid3D([6879,6869,6020,6556],0); -ELEMENTS[31174] = Fluid3D([12575,11705,11760,11801],0); -ELEMENTS[31175] = Fluid3D([16988,17051,16772,16579],0); -ELEMENTS[31176] = Fluid3D([11542,12122,11131,11474],0); -ELEMENTS[31177] = Fluid3D([11542,12122,11474,12666],0); -ELEMENTS[31178] = Fluid3D([12122,11131,11474,12016],0); -ELEMENTS[31179] = Fluid3D([11131,11542,11474,10004],0); -ELEMENTS[31180] = Fluid3D([7829,8412,8635,8810],0); -ELEMENTS[31181] = Fluid3D([7829,8412,8810,8006],0); -ELEMENTS[31182] = Fluid3D([8412,8635,8810,9544],0); -ELEMENTS[31183] = Fluid3D([8635,7829,8810,8503],0); -ELEMENTS[31184] = Fluid3D([7829,8810,8503,8702],0); -ELEMENTS[31185] = Fluid3D([8810,8503,8702,9413],0); -ELEMENTS[31186] = Fluid3D([8503,8702,9413,8759],0); -ELEMENTS[31187] = Fluid3D([8702,8810,9413,9306],0); -ELEMENTS[31188] = Fluid3D([8702,8810,9306,8006],0); -ELEMENTS[31189] = Fluid3D([8810,9413,9306,9785],0); -ELEMENTS[31190] = Fluid3D([8810,8503,9413,8635],0); -ELEMENTS[31191] = Fluid3D([8635,7829,8503,7921],0); -ELEMENTS[31192] = Fluid3D([7829,8503,7921,7112],0); -ELEMENTS[31193] = Fluid3D([8503,8635,7921,8342],0); -ELEMENTS[31194] = Fluid3D([8635,7829,7921,7842],0); -ELEMENTS[31195] = Fluid3D([9944,9179,9832,9506],0); -ELEMENTS[31196] = Fluid3D([6950,6657,7519,6998],0); -ELEMENTS[31197] = Fluid3D([6657,7519,6998,6793],0); -ELEMENTS[31198] = Fluid3D([7519,6950,6998,7745],0); -ELEMENTS[31199] = Fluid3D([6950,6657,6998,6112],0); -ELEMENTS[31200] = Fluid3D([6998,6657,6793,6200],0); -ELEMENTS[31201] = Fluid3D([6998,6657,6200,6112],0); -ELEMENTS[31202] = Fluid3D([13453,13829,13369,14601],0); -ELEMENTS[31203] = Fluid3D([7488,6863,7390,8007],0); -ELEMENTS[31204] = Fluid3D([9560,9143,8919,9962],0); -ELEMENTS[31205] = Fluid3D([6521,6682,6229,5863],0); -ELEMENTS[31206] = Fluid3D([8196,7542,7498,7664],0); -ELEMENTS[31207] = Fluid3D([17349,17089,17286,16782],0); -ELEMENTS[31208] = Fluid3D([15189,15559,15808,15305],0); -ELEMENTS[31209] = Fluid3D([11780,11512,10781,11452],0); -ELEMENTS[31210] = Fluid3D([8751,8233,7777,7866],0); -ELEMENTS[31211] = Fluid3D([6197,5831,5830,6388],0); -ELEMENTS[31212] = Fluid3D([2152,2311,2083,2171],0); -ELEMENTS[31213] = Fluid3D([10985,10264,10463,11775],0); -ELEMENTS[31214] = Fluid3D([16215,15931,15617,15854],0); -ELEMENTS[31215] = Fluid3D([9142,8789,8188,8927],0); -ELEMENTS[31216] = Fluid3D([15212,14970,14476,15169],0); -ELEMENTS[31217] = Fluid3D([15835,15228,15516,15293],0); -ELEMENTS[31218] = Fluid3D([15228,15516,15293,14310],0); -ELEMENTS[31219] = Fluid3D([16450,16886,16434,16246],0); -ELEMENTS[31220] = Fluid3D([12591,13456,12612,13027],0); -ELEMENTS[31221] = Fluid3D([6905,7234,6467,7288],0); -ELEMENTS[31222] = Fluid3D([6299,6153,6372,6964],0); -ELEMENTS[31223] = Fluid3D([6153,6372,6964,6317],0); -ELEMENTS[31224] = Fluid3D([6372,6964,6317,6532],0); -ELEMENTS[31225] = Fluid3D([6153,6372,6317,5733],0); -ELEMENTS[31226] = Fluid3D([15387,15205,15401,16007],0); -ELEMENTS[31227] = Fluid3D([2528,2550,2743,2350],0); -ELEMENTS[31228] = Fluid3D([14740,15107,14785,15383],0); -ELEMENTS[31229] = Fluid3D([14740,15107,15383,15322],0); -ELEMENTS[31230] = Fluid3D([14785,14740,15383,14627],0); -ELEMENTS[31231] = Fluid3D([15107,14785,15383,15439],0); -ELEMENTS[31232] = Fluid3D([9180,9974,9266,9888],0); -ELEMENTS[31233] = Fluid3D([9266,9180,9888,9097],0); -ELEMENTS[31234] = Fluid3D([9888,9266,9097,9856],0); -ELEMENTS[31235] = Fluid3D([9266,9097,9856,8951],0); -ELEMENTS[31236] = Fluid3D([9266,9097,8951,8374],0); -ELEMENTS[31237] = Fluid3D([9266,9097,8374,9180],0); -ELEMENTS[31238] = Fluid3D([9097,9888,9856,10346],0); -ELEMENTS[31239] = Fluid3D([9097,9856,8951,9368],0); -ELEMENTS[31240] = Fluid3D([9856,8951,9368,10112],0); -ELEMENTS[31241] = Fluid3D([9368,9856,10112,10366],0); -ELEMENTS[31242] = Fluid3D([9097,8951,8374,8089],0); -ELEMENTS[31243] = Fluid3D([8951,9266,8374,9020],0); -ELEMENTS[31244] = Fluid3D([8374,9097,8089,8495],0); -ELEMENTS[31245] = Fluid3D([8089,8374,8495,7627],0); -ELEMENTS[31246] = Fluid3D([8374,9097,8495,9180],0); -ELEMENTS[31247] = Fluid3D([8089,8374,7627,7652],0); -ELEMENTS[31248] = Fluid3D([8374,8495,7627,8058],0); -ELEMENTS[31249] = Fluid3D([9856,9266,8951,10112],0); -ELEMENTS[31250] = Fluid3D([9180,9974,9888,10027],0); -ELEMENTS[31251] = Fluid3D([9974,9266,9888,10403],0); -ELEMENTS[31252] = Fluid3D([9856,10112,10366,11293],0); -ELEMENTS[31253] = Fluid3D([17216,17068,16757,16871],0); -ELEMENTS[31254] = Fluid3D([9999,11024,10753,10723],0); -ELEMENTS[31255] = Fluid3D([9999,11024,10723,10546],0); -ELEMENTS[31256] = Fluid3D([11024,10723,10546,11501],0); -ELEMENTS[31257] = Fluid3D([11024,10723,11501,11666],0); -ELEMENTS[31258] = Fluid3D([10723,10546,11501,10767],0); -ELEMENTS[31259] = Fluid3D([10546,11024,11501,11434],0); -ELEMENTS[31260] = Fluid3D([11501,10546,11434,11014],0); -ELEMENTS[31261] = Fluid3D([10546,11434,11014,10425],0); -ELEMENTS[31262] = Fluid3D([10723,10546,10767,9702],0); -ELEMENTS[31263] = Fluid3D([11024,11501,11434,12018],0); -ELEMENTS[31264] = Fluid3D([11501,11434,12018,12646],0); -ELEMENTS[31265] = Fluid3D([11024,11501,12018,11666],0); -ELEMENTS[31266] = Fluid3D([11434,11501,11014,12036],0); -ELEMENTS[31267] = Fluid3D([11014,11434,12036,12181],0); -ELEMENTS[31268] = Fluid3D([11434,11501,12036,12646],0); -ELEMENTS[31269] = Fluid3D([10723,10546,9702,9999],0); -ELEMENTS[31270] = Fluid3D([11024,10753,10723,11666],0); -ELEMENTS[31271] = Fluid3D([11501,10723,10767,11954],0); -ELEMENTS[31272] = Fluid3D([5069,4608,4561,4339],0); -ELEMENTS[31273] = Fluid3D([4608,4561,4339,4255],0); -ELEMENTS[31274] = Fluid3D([4339,4608,4255,4288],0); -ELEMENTS[31275] = Fluid3D([4608,4561,4255,4900],0); -ELEMENTS[31276] = Fluid3D([4255,4608,4900,4752],0); -ELEMENTS[31277] = Fluid3D([4255,4608,4752,4701],0); -ELEMENTS[31278] = Fluid3D([4608,4752,4701,5151],0); -ELEMENTS[31279] = Fluid3D([4752,4701,5151,5370],0); -ELEMENTS[31280] = Fluid3D([4752,4701,5370,4870],0); -ELEMENTS[31281] = Fluid3D([4752,4701,4870,4221],0); -ELEMENTS[31282] = Fluid3D([7578,8290,7486,7985],0); -ELEMENTS[31283] = Fluid3D([8290,7486,7985,8382],0); -ELEMENTS[31284] = Fluid3D([14484,15104,14653,13906],0); -ELEMENTS[31285] = Fluid3D([2535,2842,2687,2872],0); -ELEMENTS[31286] = Fluid3D([8515,8251,8140,9220],0); -ELEMENTS[31287] = Fluid3D([5512,5549,4935,5193],0); -ELEMENTS[31288] = Fluid3D([13194,12312,13098,12889],0); -ELEMENTS[31289] = Fluid3D([13194,12312,12889,12519],0); -ELEMENTS[31290] = Fluid3D([13098,13194,12889,13952],0); -ELEMENTS[31291] = Fluid3D([12312,13098,12889,12010],0); -ELEMENTS[31292] = Fluid3D([10803,11314,10918,11995],0); -ELEMENTS[31293] = Fluid3D([16365,16945,16560,16202],0); -ELEMENTS[31294] = Fluid3D([13809,13156,13475,13412],0); -ELEMENTS[31295] = Fluid3D([13156,13475,13412,12473],0); -ELEMENTS[31296] = Fluid3D([13809,13156,13412,14098],0); -ELEMENTS[31297] = Fluid3D([13412,13156,12473,12161],0); -ELEMENTS[31298] = Fluid3D([13475,13809,13412,14177],0); -ELEMENTS[31299] = Fluid3D([13156,13412,14098,13172],0); -ELEMENTS[31300] = Fluid3D([13156,13412,13172,12161],0); -ELEMENTS[31301] = Fluid3D([14117,14396,14453,15109],0); -ELEMENTS[31302] = Fluid3D([5790,5776,6254,5616],0); -ELEMENTS[31303] = Fluid3D([5776,6254,5616,5975],0); -ELEMENTS[31304] = Fluid3D([5790,5776,5616,4991],0); -ELEMENTS[31305] = Fluid3D([6254,5616,5975,6540],0); -ELEMENTS[31306] = Fluid3D([6254,5790,5616,6004],0); -ELEMENTS[31307] = Fluid3D([5776,6254,5975,6099],0); -ELEMENTS[31308] = Fluid3D([5616,5776,5975,5162],0); -ELEMENTS[31309] = Fluid3D([15329,14996,15362,15526],0); -ELEMENTS[31310] = Fluid3D([8639,8692,9385,8858],0); -ELEMENTS[31311] = Fluid3D([5211,5059,4839,5488],0); -ELEMENTS[31312] = Fluid3D([12877,12186,12356,12261],0); -ELEMENTS[31313] = Fluid3D([10516,11276,11514,11332],0); -ELEMENTS[31314] = Fluid3D([16225,16003,16021,15605],0); -ELEMENTS[31315] = Fluid3D([16003,16021,15605,15420],0); -ELEMENTS[31316] = Fluid3D([16225,16003,15605,15814],0); -ELEMENTS[31317] = Fluid3D([16021,16225,15605,15904],0); -ELEMENTS[31318] = Fluid3D([7627,7230,6757,7367],0); -ELEMENTS[31319] = Fluid3D([6707,6780,7233,6472],0); -ELEMENTS[31320] = Fluid3D([11440,11077,10679,10413],0); -ELEMENTS[31321] = Fluid3D([10679,11440,10413,11013],0); -ELEMENTS[31322] = Fluid3D([11440,11077,10413,10672],0); -ELEMENTS[31323] = Fluid3D([11440,10413,11013,10768],0); -ELEMENTS[31324] = Fluid3D([11440,10413,10768,10672],0); -ELEMENTS[31325] = Fluid3D([10413,10768,10672,9615],0); -ELEMENTS[31326] = Fluid3D([10413,11013,10768,10170],0); -ELEMENTS[31327] = Fluid3D([10413,10768,9615,10170],0); -ELEMENTS[31328] = Fluid3D([11013,10768,10170,11229],0); -ELEMENTS[31329] = Fluid3D([10679,11440,11013,11732],0); -ELEMENTS[31330] = Fluid3D([10413,10679,11013,9591],0); -ELEMENTS[31331] = Fluid3D([11077,10679,10413,9591],0); -ELEMENTS[31332] = Fluid3D([12592,11966,12932,11769],0); -ELEMENTS[31333] = Fluid3D([11110,11997,11965,11498],0); -ELEMENTS[31334] = Fluid3D([5347,4854,5157,4912],0); -ELEMENTS[31335] = Fluid3D([5971,6669,6460,6066],0); -ELEMENTS[31336] = Fluid3D([5872,5585,6192,5951],0); -ELEMENTS[31337] = Fluid3D([15391,15526,15999,15780],0); -ELEMENTS[31338] = Fluid3D([12147,12054,12884,12549],0); -ELEMENTS[31339] = Fluid3D([14058,13863,14564,13626],0); -ELEMENTS[31340] = Fluid3D([12687,11781,12023,12758],0); -ELEMENTS[31341] = Fluid3D([15672,16100,16150,15530],0); -ELEMENTS[31342] = Fluid3D([4019,3635,3584,3658],0); -ELEMENTS[31343] = Fluid3D([15872,15677,16260,16023],0); -ELEMENTS[31344] = Fluid3D([12177,11390,12093,11405],0); -ELEMENTS[31345] = Fluid3D([10249,11228,10940,11509],0); -ELEMENTS[31346] = Fluid3D([7140,6335,6334,6441],0); -ELEMENTS[31347] = Fluid3D([6335,6334,6441,5751],0); -ELEMENTS[31348] = Fluid3D([12187,12378,12942,12802],0); -ELEMENTS[31349] = Fluid3D([9564,9618,8884,10037],0); -ELEMENTS[31350] = Fluid3D([5507,5945,5982,6147],0); -ELEMENTS[31351] = Fluid3D([5982,5507,6147,6273],0); -ELEMENTS[31352] = Fluid3D([6147,5982,6273,6897],0); -ELEMENTS[31353] = Fluid3D([5507,6147,6273,5695],0); -ELEMENTS[31354] = Fluid3D([5945,5982,6147,6897],0); -ELEMENTS[31355] = Fluid3D([5507,5945,6147,5794],0); -ELEMENTS[31356] = Fluid3D([2932,3136,3074,2912],0); -ELEMENTS[31357] = Fluid3D([9834,10055,9616,10472],0); -ELEMENTS[31358] = Fluid3D([9834,10055,10472,10625],0); -ELEMENTS[31359] = Fluid3D([9616,9834,10472,10458],0); -ELEMENTS[31360] = Fluid3D([9834,10472,10458,10625],0); -ELEMENTS[31361] = Fluid3D([10458,9834,10625,10771],0); -ELEMENTS[31362] = Fluid3D([10472,10458,10625,11489],0); -ELEMENTS[31363] = Fluid3D([10055,9616,10472,9963],0); -ELEMENTS[31364] = Fluid3D([9834,10055,10625,10771],0); -ELEMENTS[31365] = Fluid3D([10055,10472,10625,11188],0); -ELEMENTS[31366] = Fluid3D([15666,15125,15642,15334],0); -ELEMENTS[31367] = Fluid3D([15125,15642,15334,15257],0); -ELEMENTS[31368] = Fluid3D([15125,15642,15257,15720],0); -ELEMENTS[31369] = Fluid3D([15642,15666,15334,15967],0); -ELEMENTS[31370] = Fluid3D([9648,9566,10199,9472],0); -ELEMENTS[31371] = Fluid3D([5595,5701,5458,5212],0); -ELEMENTS[31372] = Fluid3D([5298,4722,5280,5109],0); -ELEMENTS[31373] = Fluid3D([5280,5298,5109,5724],0); -ELEMENTS[31374] = Fluid3D([5280,5298,5724,6069],0); -ELEMENTS[31375] = Fluid3D([5298,5109,5724,5824],0); -ELEMENTS[31376] = Fluid3D([5298,5724,6069,5824],0); -ELEMENTS[31377] = Fluid3D([5298,4722,5109,4793],0); -ELEMENTS[31378] = Fluid3D([5109,5280,5724,5461],0); -ELEMENTS[31379] = Fluid3D([5724,5109,5461,5824],0); -ELEMENTS[31380] = Fluid3D([3106,3178,2910,2823],0); -ELEMENTS[31381] = Fluid3D([17236,16836,16831,16889],0); -ELEMENTS[31382] = Fluid3D([16836,16831,16889,16423],0); -ELEMENTS[31383] = Fluid3D([16831,16889,16423,16658],0); -ELEMENTS[31384] = Fluid3D([16831,17236,16889,17113],0); -ELEMENTS[31385] = Fluid3D([17236,16836,16889,17168],0); -ELEMENTS[31386] = Fluid3D([3157,3222,3560,3187],0); -ELEMENTS[31387] = Fluid3D([14110,14081,13922,14690],0); -ELEMENTS[31388] = Fluid3D([9712,9629,8945,9120],0); -ELEMENTS[31389] = Fluid3D([5892,5292,5498,5450],0); -ELEMENTS[31390] = Fluid3D([9287,9969,9108,8979],0); -ELEMENTS[31391] = Fluid3D([11664,12019,12504,11219],0); -ELEMENTS[31392] = Fluid3D([3446,3823,3603,3267],0); -ELEMENTS[31393] = Fluid3D([3603,3446,3267,3040],0); -ELEMENTS[31394] = Fluid3D([3446,3823,3267,3273],0); -ELEMENTS[31395] = Fluid3D([3823,3603,3267,3678],0); -ELEMENTS[31396] = Fluid3D([3603,3267,3678,3238],0); -ELEMENTS[31397] = Fluid3D([3603,3267,3238,3040],0); -ELEMENTS[31398] = Fluid3D([3823,3603,3678,4185],0); -ELEMENTS[31399] = Fluid3D([3267,3823,3678,3581],0); -ELEMENTS[31400] = Fluid3D([3678,3267,3581,3094],0); -ELEMENTS[31401] = Fluid3D([3823,3678,3581,4036],0); -ELEMENTS[31402] = Fluid3D([3823,3678,4036,4185],0); -ELEMENTS[31403] = Fluid3D([3267,3823,3581,3392],0); -ELEMENTS[31404] = Fluid3D([3581,3823,4036,3949],0); -ELEMENTS[31405] = Fluid3D([3823,3581,3392,3949],0); -ELEMENTS[31406] = Fluid3D([3678,3581,4036,3776],0); -ELEMENTS[31407] = Fluid3D([3678,3581,3776,3094],0); -ELEMENTS[31408] = Fluid3D([4036,3678,3776,4059],0); -ELEMENTS[31409] = Fluid3D([3581,4036,3776,4141],0); -ELEMENTS[31410] = Fluid3D([4036,3776,4141,4059],0); -ELEMENTS[31411] = Fluid3D([3581,4036,4141,3949],0); -ELEMENTS[31412] = Fluid3D([3581,3267,3392,3073],0); -ELEMENTS[31413] = Fluid3D([3581,3267,3073,3094],0); -ELEMENTS[31414] = Fluid3D([3392,3581,3073,3448],0); -ELEMENTS[31415] = Fluid3D([3581,3073,3448,3362],0); -ELEMENTS[31416] = Fluid3D([3581,3073,3362,3094],0); -ELEMENTS[31417] = Fluid3D([3267,3392,3073,3026],0); -ELEMENTS[31418] = Fluid3D([3073,3448,3362,3077],0); -ELEMENTS[31419] = Fluid3D([3362,3073,3077,2969],0); -ELEMENTS[31420] = Fluid3D([3073,3448,3077,3019],0); -ELEMENTS[31421] = Fluid3D([3448,3362,3077,3675],0); -ELEMENTS[31422] = Fluid3D([3392,3581,3448,3949],0); -ELEMENTS[31423] = Fluid3D([3448,3581,3362,3786],0); -ELEMENTS[31424] = Fluid3D([3448,3581,3786,3949],0); -ELEMENTS[31425] = Fluid3D([3581,3362,3786,3776],0); -ELEMENTS[31426] = Fluid3D([3362,3448,3786,3675],0); -ELEMENTS[31427] = Fluid3D([3448,3786,3675,3913],0); -ELEMENTS[31428] = Fluid3D([3786,3675,3913,4101],0); -ELEMENTS[31429] = Fluid3D([3786,3675,4101,3613],0); -ELEMENTS[31430] = Fluid3D([3786,3675,3613,3362],0); -ELEMENTS[31431] = Fluid3D([3675,4101,3613,3647],0); -ELEMENTS[31432] = Fluid3D([3448,3786,3913,3949],0); -ELEMENTS[31433] = Fluid3D([4101,3613,3647,3789],0); -ELEMENTS[31434] = Fluid3D([3613,3647,3789,3335],0); -ELEMENTS[31435] = Fluid3D([3073,3392,3448,3019],0); -ELEMENTS[31436] = Fluid3D([3267,3823,3392,3273],0); -ELEMENTS[31437] = Fluid3D([4004,4379,4255,4561],0); -ELEMENTS[31438] = Fluid3D([14005,14727,14694,14357],0); -ELEMENTS[31439] = Fluid3D([13560,13024,12661,12813],0); -ELEMENTS[31440] = Fluid3D([10932,11130,11843,10835],0); -ELEMENTS[31441] = Fluid3D([4534,4303,4486,4126],0); -ELEMENTS[31442] = Fluid3D([13418,12776,13329,12642],0); -ELEMENTS[31443] = Fluid3D([12776,13329,12642,12457],0); -ELEMENTS[31444] = Fluid3D([13418,12776,12642,12493],0); -ELEMENTS[31445] = Fluid3D([13329,12642,12457,12872],0); -ELEMENTS[31446] = Fluid3D([12457,13329,12872,12946],0); -ELEMENTS[31447] = Fluid3D([13329,12642,12872,13446],0); -ELEMENTS[31448] = Fluid3D([13329,12642,13446,13418],0); -ELEMENTS[31449] = Fluid3D([12642,12872,13446,12669],0); -ELEMENTS[31450] = Fluid3D([13446,12642,12669,13479],0); -ELEMENTS[31451] = Fluid3D([12669,13446,13479,13487],0); -ELEMENTS[31452] = Fluid3D([12669,13446,13487,12872],0); -ELEMENTS[31453] = Fluid3D([13446,13479,13487,14571],0); -ELEMENTS[31454] = Fluid3D([12776,13329,12457,13150],0); -ELEMENTS[31455] = Fluid3D([12872,13329,13446,13781],0); -ELEMENTS[31456] = Fluid3D([12872,13329,13781,13834],0); -ELEMENTS[31457] = Fluid3D([13329,13446,13781,14571],0); -ELEMENTS[31458] = Fluid3D([13446,12872,13781,13487],0); -ELEMENTS[31459] = Fluid3D([12642,12457,12872,11927],0); -ELEMENTS[31460] = Fluid3D([12457,12872,11927,12210],0); -ELEMENTS[31461] = Fluid3D([12872,12642,11927,12669],0); -ELEMENTS[31462] = Fluid3D([11927,12457,12210,11556],0); -ELEMENTS[31463] = Fluid3D([12642,12457,11927,11676],0); -ELEMENTS[31464] = Fluid3D([12457,12210,11556,12498],0); -ELEMENTS[31465] = Fluid3D([11927,12457,11556,11676],0); -ELEMENTS[31466] = Fluid3D([12457,12872,12210,12946],0); -ELEMENTS[31467] = Fluid3D([12872,11927,12210,12788],0); -ELEMENTS[31468] = Fluid3D([12210,11927,11556,11273],0); -ELEMENTS[31469] = Fluid3D([11556,12210,11273,11985],0); -ELEMENTS[31470] = Fluid3D([11927,11556,11273,10945],0); -ELEMENTS[31471] = Fluid3D([11556,11273,10945,10794],0); -ELEMENTS[31472] = Fluid3D([10945,11556,10794,11050],0); -ELEMENTS[31473] = Fluid3D([11556,11273,10794,11344],0); -ELEMENTS[31474] = Fluid3D([10794,11556,11344,11074],0); -ELEMENTS[31475] = Fluid3D([10794,11556,11074,11050],0); -ELEMENTS[31476] = Fluid3D([11556,11273,11344,11985],0); -ELEMENTS[31477] = Fluid3D([12210,11927,11273,12125],0); -ELEMENTS[31478] = Fluid3D([11273,12210,12125,11837],0); -ELEMENTS[31479] = Fluid3D([12210,11927,12125,12788],0); -ELEMENTS[31480] = Fluid3D([12125,11273,11837,11346],0); -ELEMENTS[31481] = Fluid3D([11273,11837,11346,10562],0); -ELEMENTS[31482] = Fluid3D([12125,11273,11346,10869],0); -ELEMENTS[31483] = Fluid3D([11273,12210,11837,11985],0); -ELEMENTS[31484] = Fluid3D([11927,11273,12125,10869],0); -ELEMENTS[31485] = Fluid3D([11273,11927,10945,10869],0); -ELEMENTS[31486] = Fluid3D([11837,12125,11346,12160],0); -ELEMENTS[31487] = Fluid3D([13329,13781,13834,14282],0); -ELEMENTS[31488] = Fluid3D([11927,11556,10945,11676],0); -ELEMENTS[31489] = Fluid3D([12210,12125,11837,12789],0); -ELEMENTS[31490] = Fluid3D([12210,12125,12789,12788],0); -ELEMENTS[31491] = Fluid3D([12125,12789,12788,12495],0); -ELEMENTS[31492] = Fluid3D([12788,12125,12495,12191],0); -ELEMENTS[31493] = Fluid3D([12125,12789,12495,11837],0); -ELEMENTS[31494] = Fluid3D([11837,12210,12789,12400],0); -ELEMENTS[31495] = Fluid3D([12789,11837,12400,12315],0); -ELEMENTS[31496] = Fluid3D([11837,12210,12400,11985],0); -ELEMENTS[31497] = Fluid3D([14332,13376,14159,13565],0); -ELEMENTS[31498] = Fluid3D([14332,13376,13565,13693],0); -ELEMENTS[31499] = Fluid3D([13376,13565,13693,13005],0); -ELEMENTS[31500] = Fluid3D([13565,13693,13005,13578],0); -ELEMENTS[31501] = Fluid3D([13565,13693,13578,14366],0); -ELEMENTS[31502] = Fluid3D([13376,13565,13005,12481],0); -ELEMENTS[31503] = Fluid3D([13565,14332,13693,14596],0); -ELEMENTS[31504] = Fluid3D([13005,13565,13578,13610],0); -ELEMENTS[31505] = Fluid3D([13693,13005,13578,12674],0); -ELEMENTS[31506] = Fluid3D([13376,14159,13565,13349],0); -ELEMENTS[31507] = Fluid3D([13693,13376,13005,12824],0); -ELEMENTS[31508] = Fluid3D([13376,13005,12824,12481],0); -ELEMENTS[31509] = Fluid3D([12877,12356,13269,12261],0); -ELEMENTS[31510] = Fluid3D([6441,6023,6613,6748],0); -ELEMENTS[31511] = Fluid3D([6023,6613,6748,6646],0); -ELEMENTS[31512] = Fluid3D([6441,6023,6748,6164],0); -ELEMENTS[31513] = Fluid3D([6613,6441,6748,7269],0); -ELEMENTS[31514] = Fluid3D([6748,6613,7269,7168],0); -ELEMENTS[31515] = Fluid3D([6441,6748,7269,7054],0); -ELEMENTS[31516] = Fluid3D([6441,6748,7054,6164],0); -ELEMENTS[31517] = Fluid3D([6613,6441,7269,6574],0); -ELEMENTS[31518] = Fluid3D([7269,6441,7054,7140],0); -ELEMENTS[31519] = Fluid3D([6748,7269,7054,7585],0); -ELEMENTS[31520] = Fluid3D([6748,7269,7585,7295],0); -ELEMENTS[31521] = Fluid3D([7269,7585,7295,8031],0); -ELEMENTS[31522] = Fluid3D([7585,7295,8031,7840],0); -ELEMENTS[31523] = Fluid3D([7295,8031,7840,7504],0); -ELEMENTS[31524] = Fluid3D([7295,8031,7504,7168],0); -ELEMENTS[31525] = Fluid3D([7295,8031,7168,7718],0); -ELEMENTS[31526] = Fluid3D([7504,7295,7168,6646],0); -ELEMENTS[31527] = Fluid3D([7840,7295,7504,6646],0); -ELEMENTS[31528] = Fluid3D([7840,7295,6646,7585],0); -ELEMENTS[31529] = Fluid3D([7504,7840,6646,7395],0); -ELEMENTS[31530] = Fluid3D([7840,6646,7395,7585],0); -ELEMENTS[31531] = Fluid3D([7504,7840,7395,8363],0); -ELEMENTS[31532] = Fluid3D([7840,7395,8363,8449],0); -ELEMENTS[31533] = Fluid3D([7840,7395,8449,8081],0); -ELEMENTS[31534] = Fluid3D([7504,7840,8363,8031],0); -ELEMENTS[31535] = Fluid3D([8363,7840,8449,8499],0); -ELEMENTS[31536] = Fluid3D([8363,7840,8499,8031],0); -ELEMENTS[31537] = Fluid3D([8449,8363,8499,9254],0); -ELEMENTS[31538] = Fluid3D([7168,7295,7718,7269],0); -ELEMENTS[31539] = Fluid3D([7295,8031,7718,7269],0); -ELEMENTS[31540] = Fluid3D([7295,7168,6646,6748],0); -ELEMENTS[31541] = Fluid3D([6646,7295,6748,7585],0); -ELEMENTS[31542] = Fluid3D([7269,7054,7585,7825],0); -ELEMENTS[31543] = Fluid3D([7269,7054,7825,7140],0); -ELEMENTS[31544] = Fluid3D([7054,7585,7825,7719],0); -ELEMENTS[31545] = Fluid3D([7585,7825,7719,8519],0); -ELEMENTS[31546] = Fluid3D([7054,7585,7719,7299],0); -ELEMENTS[31547] = Fluid3D([7825,7054,7719,7235],0); -ELEMENTS[31548] = Fluid3D([7054,7719,7235,6873],0); -ELEMENTS[31549] = Fluid3D([7235,7054,6873,6164],0); -ELEMENTS[31550] = Fluid3D([7719,7235,6873,7723],0); -ELEMENTS[31551] = Fluid3D([7719,7235,7723,8470],0); -ELEMENTS[31552] = Fluid3D([7723,7719,8470,8519],0); -ELEMENTS[31553] = Fluid3D([7723,7719,8519,8081],0); -ELEMENTS[31554] = Fluid3D([7054,7719,6873,7299],0); -ELEMENTS[31555] = Fluid3D([7723,7719,8081,7299],0); -ELEMENTS[31556] = Fluid3D([7825,7054,7235,7140],0); -ELEMENTS[31557] = Fluid3D([7054,7235,7140,6335],0); -ELEMENTS[31558] = Fluid3D([7054,7235,6335,6164],0); -ELEMENTS[31559] = Fluid3D([6748,7269,7295,7168],0); -ELEMENTS[31560] = Fluid3D([7054,6748,7585,7299],0); -ELEMENTS[31561] = Fluid3D([7585,7269,7825,8583],0); -ELEMENTS[31562] = Fluid3D([15677,15872,15386,15791],0); -ELEMENTS[31563] = Fluid3D([15872,15386,15791,15120],0); -ELEMENTS[31564] = Fluid3D([14381,15058,14711,15157],0); -ELEMENTS[31565] = Fluid3D([15058,14711,15157,15475],0); -ELEMENTS[31566] = Fluid3D([14381,15058,15157,15316],0); -ELEMENTS[31567] = Fluid3D([14711,15157,15475,15449],0); -ELEMENTS[31568] = Fluid3D([15475,14711,15449,15105],0); -ELEMENTS[31569] = Fluid3D([15157,15475,15449,15675],0); -ELEMENTS[31570] = Fluid3D([15475,15449,15675,16091],0); -ELEMENTS[31571] = Fluid3D([15675,15475,16091,16291],0); -ELEMENTS[31572] = Fluid3D([15449,15675,16091,16293],0); -ELEMENTS[31573] = Fluid3D([15475,15449,16091,15681],0); -ELEMENTS[31574] = Fluid3D([15475,15449,15681,15105],0); -ELEMENTS[31575] = Fluid3D([15157,15475,15675,15316],0); -ELEMENTS[31576] = Fluid3D([15449,15157,15675,15304],0); -ELEMENTS[31577] = Fluid3D([15157,15675,15304,15316],0); -ELEMENTS[31578] = Fluid3D([15449,15681,15105,15472],0); -ELEMENTS[31579] = Fluid3D([14711,14381,15157,14588],0); -ELEMENTS[31580] = Fluid3D([15449,16091,15681,15895],0); -ELEMENTS[31581] = Fluid3D([15681,15449,15895,15472],0); -ELEMENTS[31582] = Fluid3D([15304,15157,15316,14909],0); -ELEMENTS[31583] = Fluid3D([15304,15157,14909,14472],0); -ELEMENTS[31584] = Fluid3D([15157,14909,14472,15316],0); -ELEMENTS[31585] = Fluid3D([14909,15304,14472,15047],0); -ELEMENTS[31586] = Fluid3D([15304,15157,14472,14588],0); -ELEMENTS[31587] = Fluid3D([15157,14472,14588,14381],0); -ELEMENTS[31588] = Fluid3D([14472,14588,14381,13598],0); -ELEMENTS[31589] = Fluid3D([15304,15157,14588,14711],0); -ELEMENTS[31590] = Fluid3D([14472,15304,14588,14678],0); -ELEMENTS[31591] = Fluid3D([14588,14472,14678,13598],0); -ELEMENTS[31592] = Fluid3D([15157,14472,14381,15316],0); -ELEMENTS[31593] = Fluid3D([14472,15304,14678,15047],0); -ELEMENTS[31594] = Fluid3D([15058,14711,15475,15038],0); -ELEMENTS[31595] = Fluid3D([15157,15058,15475,15316],0); -ELEMENTS[31596] = Fluid3D([4561,4900,5219,4730],0); -ELEMENTS[31597] = Fluid3D([6904,7658,7319,6951],0); -ELEMENTS[31598] = Fluid3D([7311,6867,7078,7626],0); -ELEMENTS[31599] = Fluid3D([7311,6867,7626,7520],0); -ELEMENTS[31600] = Fluid3D([11377,11055,11782,12222],0); -ELEMENTS[31601] = Fluid3D([18522,18524,18602,18609],0); -ELEMENTS[31602] = Fluid3D([14194,14529,14528,13760],0); -ELEMENTS[31603] = Fluid3D([12848,12155,13079,12803],0); -ELEMENTS[31604] = Fluid3D([17564,17755,17638,17889],0); -ELEMENTS[31605] = Fluid3D([15874,15433,15671,15863],0); -ELEMENTS[31606] = Fluid3D([15433,15671,15863,15328],0); -ELEMENTS[31607] = Fluid3D([15874,15433,15863,15902],0); -ELEMENTS[31608] = Fluid3D([3945,3875,3669,4350],0); -ELEMENTS[31609] = Fluid3D([6149,6514,6053,6535],0); -ELEMENTS[31610] = Fluid3D([4937,5155,5486,5352],0); -ELEMENTS[31611] = Fluid3D([8639,9177,8217,8858],0); -ELEMENTS[31612] = Fluid3D([11514,10854,10761,11231],0); -ELEMENTS[31613] = Fluid3D([13886,14575,14257,13985],0); -ELEMENTS[31614] = Fluid3D([15510,15836,15399,16000],0); -ELEMENTS[31615] = Fluid3D([17059,16826,17257,17087],0); -ELEMENTS[31616] = Fluid3D([8058,7897,7827,8616],0); -ELEMENTS[31617] = Fluid3D([7827,8058,8616,8542],0); -ELEMENTS[31618] = Fluid3D([8616,7827,8542,8384],0); -ELEMENTS[31619] = Fluid3D([8058,8616,8542,9086],0); -ELEMENTS[31620] = Fluid3D([8542,8616,8384,9036],0); -ELEMENTS[31621] = Fluid3D([5152,5227,4849,4469],0); -ELEMENTS[31622] = Fluid3D([10926,11926,11739,12310],0); -ELEMENTS[31623] = Fluid3D([13119,13021,12426,13583],0); -ELEMENTS[31624] = Fluid3D([15910,16457,16195,16281],0); -ELEMENTS[31625] = Fluid3D([15910,16457,16281,16403],0); -ELEMENTS[31626] = Fluid3D([16457,16281,16403,16702],0); -ELEMENTS[31627] = Fluid3D([11730,11728,11350,12237],0); -ELEMENTS[31628] = Fluid3D([3720,3893,3480,3671],0); -ELEMENTS[31629] = Fluid3D([3893,3480,3671,3668],0); -ELEMENTS[31630] = Fluid3D([3671,3893,3668,3642],0); -ELEMENTS[31631] = Fluid3D([3671,3893,3642,3820],0); -ELEMENTS[31632] = Fluid3D([3642,3671,3820,3417],0); -ELEMENTS[31633] = Fluid3D([3820,3642,3417,3214],0); -ELEMENTS[31634] = Fluid3D([3642,3671,3417,3214],0); -ELEMENTS[31635] = Fluid3D([8231,8964,8908,9444],0); -ELEMENTS[31636] = Fluid3D([7392,7365,8136,7712],0); -ELEMENTS[31637] = Fluid3D([11380,10809,11636,10746],0); -ELEMENTS[31638] = Fluid3D([10809,11636,10746,11439],0); -ELEMENTS[31639] = Fluid3D([12331,11760,11917,11840],0); -ELEMENTS[31640] = Fluid3D([17409,17128,17138,16985],0); -ELEMENTS[31641] = Fluid3D([13603,13015,12830,13350],0); -ELEMENTS[31642] = Fluid3D([11977,11905,11602,12430],0); -ELEMENTS[31643] = Fluid3D([4086,3719,4037,3617],0); -ELEMENTS[31644] = Fluid3D([8304,7515,8378,7791],0); -ELEMENTS[31645] = Fluid3D([6692,6412,7143,6462],0); -ELEMENTS[31646] = Fluid3D([15913,15744,16277,15603],0); -ELEMENTS[31647] = Fluid3D([8919,8588,9206,7961],0); -ELEMENTS[31648] = Fluid3D([9630,9801,9362,10800],0); -ELEMENTS[31649] = Fluid3D([7813,7214,7161,7853],0); -ELEMENTS[31650] = Fluid3D([14557,14406,15211,14699],0); -ELEMENTS[31651] = Fluid3D([13421,14012,14221,13730],0); -ELEMENTS[31652] = Fluid3D([14221,13421,13730,13473],0); -ELEMENTS[31653] = Fluid3D([13421,14012,13730,13366],0); -ELEMENTS[31654] = Fluid3D([14012,14221,13730,14878],0); -ELEMENTS[31655] = Fluid3D([14467,15071,14364,14789],0); -ELEMENTS[31656] = Fluid3D([9268,9021,9934,8751],0); -ELEMENTS[31657] = Fluid3D([6628,6528,7024,7407],0); -ELEMENTS[31658] = Fluid3D([3025,2694,2881,2936],0); -ELEMENTS[31659] = Fluid3D([11582,11006,10709,11830],0); -ELEMENTS[31660] = Fluid3D([16767,16355,16488,16582],0); -ELEMENTS[31661] = Fluid3D([16355,16488,16582,16136],0); -ELEMENTS[31662] = Fluid3D([16767,16355,16582,16805],0); -ELEMENTS[31663] = Fluid3D([16488,16767,16582,17022],0); -ELEMENTS[31664] = Fluid3D([16767,16582,17022,16805],0); -ELEMENTS[31665] = Fluid3D([16582,16355,16136,16496],0); -ELEMENTS[31666] = Fluid3D([16582,16355,16496,16805],0); -ELEMENTS[31667] = Fluid3D([16488,16582,16136,16623],0); -ELEMENTS[31668] = Fluid3D([16136,16582,16496,16213],0); -ELEMENTS[31669] = Fluid3D([9451,9350,10273,9715],0); -ELEMENTS[31670] = Fluid3D([9451,9350,9715,8532],0); -ELEMENTS[31671] = Fluid3D([9350,10273,9715,10400],0); -ELEMENTS[31672] = Fluid3D([10273,9451,9715,10292],0); -ELEMENTS[31673] = Fluid3D([9689,9142,10116,10001],0); -ELEMENTS[31674] = Fluid3D([15635,15353,15169,15904],0); -ELEMENTS[31675] = Fluid3D([15848,16247,16436,16099],0); -ELEMENTS[31676] = Fluid3D([3717,3534,3670,4035],0); -ELEMENTS[31677] = Fluid3D([3717,3534,4035,3801],0); -ELEMENTS[31678] = Fluid3D([3670,3717,4035,4318],0); -ELEMENTS[31679] = Fluid3D([3534,3670,4035,3769],0); -ELEMENTS[31680] = Fluid3D([4035,3534,3769,3966],0); -ELEMENTS[31681] = Fluid3D([3769,4035,3966,4449],0); -ELEMENTS[31682] = Fluid3D([3534,3670,3769,3246],0); -ELEMENTS[31683] = Fluid3D([3670,4035,3769,4011],0); -ELEMENTS[31684] = Fluid3D([4035,3769,4011,4449],0); -ELEMENTS[31685] = Fluid3D([3670,4035,4011,4318],0); -ELEMENTS[31686] = Fluid3D([3769,3670,4011,3553],0); -ELEMENTS[31687] = Fluid3D([7812,7711,7071,6925],0); -ELEMENTS[31688] = Fluid3D([5138,5622,4965,4975],0); -ELEMENTS[31689] = Fluid3D([12792,12357,12924,13307],0); -ELEMENTS[31690] = Fluid3D([12924,12792,13307,13579],0); -ELEMENTS[31691] = Fluid3D([12792,12357,13307,12610],0); -ELEMENTS[31692] = Fluid3D([12357,12924,13307,13087],0); -ELEMENTS[31693] = Fluid3D([13880,14760,14178,13883],0); -ELEMENTS[31694] = Fluid3D([6643,6691,6355,6995],0); -ELEMENTS[31695] = Fluid3D([6691,6355,6995,6660],0); -ELEMENTS[31696] = Fluid3D([6355,6995,6660,6458],0); -ELEMENTS[31697] = Fluid3D([6355,6995,6458,6969],0); -ELEMENTS[31698] = Fluid3D([6355,6643,6995,6969],0); -ELEMENTS[31699] = Fluid3D([12231,12787,11872,12167],0); -ELEMENTS[31700] = Fluid3D([11530,11856,12664,12182],0); -ELEMENTS[31701] = Fluid3D([15640,15055,15181,15037],0); -ELEMENTS[31702] = Fluid3D([11787,12582,12099,11722],0); -ELEMENTS[31703] = Fluid3D([12099,11787,11722,10984],0); -ELEMENTS[31704] = Fluid3D([12582,12099,11722,12035],0); -ELEMENTS[31705] = Fluid3D([12099,11722,12035,10984],0); -ELEMENTS[31706] = Fluid3D([12035,12099,10984,11438],0); -ELEMENTS[31707] = Fluid3D([12035,12099,11438,12438],0); -ELEMENTS[31708] = Fluid3D([11787,12582,11722,12256],0); -ELEMENTS[31709] = Fluid3D([16041,15997,16382,15604],0); -ELEMENTS[31710] = Fluid3D([3410,3482,3840,3445],0); -ELEMENTS[31711] = Fluid3D([3840,3410,3445,3575],0); -ELEMENTS[31712] = Fluid3D([3445,3840,3575,3845],0); -ELEMENTS[31713] = Fluid3D([3575,3445,3845,3479],0); -ELEMENTS[31714] = Fluid3D([3575,3445,3479,3071],0); -ELEMENTS[31715] = Fluid3D([3575,3445,3071,3410],0); -ELEMENTS[31716] = Fluid3D([3445,3845,3479,3548],0); -ELEMENTS[31717] = Fluid3D([3479,3445,3548,3145],0); -ELEMENTS[31718] = Fluid3D([3445,3845,3548,3609],0); -ELEMENTS[31719] = Fluid3D([3479,3445,3145,3071],0); -ELEMENTS[31720] = Fluid3D([3445,3145,3071,3175],0); -ELEMENTS[31721] = Fluid3D([3845,3575,3479,3876],0); -ELEMENTS[31722] = Fluid3D([3479,3845,3876,3861],0); -ELEMENTS[31723] = Fluid3D([3845,3876,3861,4273],0); -ELEMENTS[31724] = Fluid3D([3845,3876,4273,4145],0); -ELEMENTS[31725] = Fluid3D([4273,3845,4145,4089],0); -ELEMENTS[31726] = Fluid3D([3845,3575,3876,4145],0); -ELEMENTS[31727] = Fluid3D([3575,3479,3876,3367],0); -ELEMENTS[31728] = Fluid3D([3876,3861,4273,4142],0); -ELEMENTS[31729] = Fluid3D([3445,3071,3410,2954],0); -ELEMENTS[31730] = Fluid3D([3876,3861,4142,3660],0); -ELEMENTS[31731] = Fluid3D([3876,3861,3660,3479],0); -ELEMENTS[31732] = Fluid3D([3861,3845,4273,4089],0); -ELEMENTS[31733] = Fluid3D([4273,3876,4142,4606],0); -ELEMENTS[31734] = Fluid3D([3445,3548,3145,3175],0); -ELEMENTS[31735] = Fluid3D([3660,3876,3479,3367],0); -ELEMENTS[31736] = Fluid3D([4142,3876,3660,3918],0); -ELEMENTS[31737] = Fluid3D([4142,3876,3918,4048],0); -ELEMENTS[31738] = Fluid3D([3445,3840,3845,3609],0); -ELEMENTS[31739] = Fluid3D([3861,4273,4142,4416],0); -ELEMENTS[31740] = Fluid3D([4273,4142,4416,4606],0); -ELEMENTS[31741] = Fluid3D([4142,4416,4606,4695],0); -ELEMENTS[31742] = Fluid3D([3660,4142,3918,4287],0); -ELEMENTS[31743] = Fluid3D([4142,3918,4287,4293],0); -ELEMENTS[31744] = Fluid3D([3918,4287,4293,3917],0); -ELEMENTS[31745] = Fluid3D([3548,3479,3145,3250],0); -ELEMENTS[31746] = Fluid3D([3876,3660,3918,3655],0); -ELEMENTS[31747] = Fluid3D([3479,3845,3861,3548],0); -ELEMENTS[31748] = Fluid3D([3861,4142,3660,3579],0); -ELEMENTS[31749] = Fluid3D([3660,3861,3579,3479],0); -ELEMENTS[31750] = Fluid3D([3482,3840,3445,3609],0); -ELEMENTS[31751] = Fluid3D([3410,3482,3445,2954],0); -ELEMENTS[31752] = Fluid3D([16894,17307,17040,17226],0); -ELEMENTS[31753] = Fluid3D([17307,17040,17226,17579],0); -ELEMENTS[31754] = Fluid3D([17040,16894,17226,16798],0); -ELEMENTS[31755] = Fluid3D([17040,16894,16798,16574],0); -ELEMENTS[31756] = Fluid3D([17226,17040,16798,17440],0); -ELEMENTS[31757] = Fluid3D([16894,17307,17226,17312],0); -ELEMENTS[31758] = Fluid3D([16894,17226,16798,16979],0); -ELEMENTS[31759] = Fluid3D([11478,12047,11549,12354],0); -ELEMENTS[31760] = Fluid3D([10557,10690,10266,9806],0); -ELEMENTS[31761] = Fluid3D([16007,16675,16297,16437],0); -ELEMENTS[31762] = Fluid3D([16007,16675,16437,16579],0); -ELEMENTS[31763] = Fluid3D([16675,16297,16437,16772],0); -ELEMENTS[31764] = Fluid3D([16437,16675,16772,16579],0); -ELEMENTS[31765] = Fluid3D([16675,16297,16772,16778],0); -ELEMENTS[31766] = Fluid3D([16297,16437,16772,16465],0); -ELEMENTS[31767] = Fluid3D([16437,16772,16465,17051],0); -ELEMENTS[31768] = Fluid3D([16772,16437,16579,17051],0); -ELEMENTS[31769] = Fluid3D([16297,16437,16465,16069],0); -ELEMENTS[31770] = Fluid3D([16437,16465,16069,16619],0); -ELEMENTS[31771] = Fluid3D([16297,16007,16437,15517],0); -ELEMENTS[31772] = Fluid3D([14432,14531,15064,14934],0); -ELEMENTS[31773] = Fluid3D([8815,8306,8550,9374],0); -ELEMENTS[31774] = Fluid3D([8550,8815,9374,9174],0); -ELEMENTS[31775] = Fluid3D([9923,9461,10357,10130],0); -ELEMENTS[31776] = Fluid3D([6495,6659,7180,7164],0); -ELEMENTS[31777] = Fluid3D([7180,6495,7164,7266],0); -ELEMENTS[31778] = Fluid3D([6495,7164,7266,7181],0); -ELEMENTS[31779] = Fluid3D([6495,6659,7164,6271],0); -ELEMENTS[31780] = Fluid3D([7180,6495,7266,6788],0); -ELEMENTS[31781] = Fluid3D([7164,7180,7266,7925],0); -ELEMENTS[31782] = Fluid3D([7164,7180,7925,7618],0); -ELEMENTS[31783] = Fluid3D([7925,7164,7618,8068],0); -ELEMENTS[31784] = Fluid3D([7618,7925,8068,8639],0); -ELEMENTS[31785] = Fluid3D([7925,7164,8068,7745],0); -ELEMENTS[31786] = Fluid3D([7164,7618,8068,7556],0); -ELEMENTS[31787] = Fluid3D([7618,8068,7556,8692],0); -ELEMENTS[31788] = Fluid3D([7180,7266,7925,7629],0); -ELEMENTS[31789] = Fluid3D([7266,7164,7925,7745],0); -ELEMENTS[31790] = Fluid3D([7925,7266,7745,8291],0); -ELEMENTS[31791] = Fluid3D([7266,7164,7745,7181],0); -ELEMENTS[31792] = Fluid3D([7164,7745,7181,8068],0); -ELEMENTS[31793] = Fluid3D([7266,7745,8291,7392],0); -ELEMENTS[31794] = Fluid3D([7266,7745,7392,6998],0); -ELEMENTS[31795] = Fluid3D([7164,7180,7618,6659],0); -ELEMENTS[31796] = Fluid3D([7180,7925,7618,8217],0); -ELEMENTS[31797] = Fluid3D([5169,4978,4606,5249],0); -ELEMENTS[31798] = Fluid3D([12661,12479,12159,11716],0); -ELEMENTS[31799] = Fluid3D([10117,10831,10010,11131],0); -ELEMENTS[31800] = Fluid3D([10831,10010,11131,11474],0); -ELEMENTS[31801] = Fluid3D([11131,10831,11474,12016],0); -ELEMENTS[31802] = Fluid3D([16077,16625,16519,16209],0); -ELEMENTS[31803] = Fluid3D([13487,13642,13400,14057],0); -ELEMENTS[31804] = Fluid3D([13400,13487,14057,12788],0); -ELEMENTS[31805] = Fluid3D([13487,13642,14057,14072],0); -ELEMENTS[31806] = Fluid3D([8748,9356,9130,8621],0); -ELEMENTS[31807] = Fluid3D([6905,6297,6161,5788],0); -ELEMENTS[31808] = Fluid3D([12709,12750,11923,12918],0); -ELEMENTS[31809] = Fluid3D([5779,5607,6126,5486],0); -ELEMENTS[31810] = Fluid3D([7579,7597,8163,8224],0); -ELEMENTS[31811] = Fluid3D([2275,2311,2171,2083],0); -ELEMENTS[31812] = Fluid3D([17693,17840,17960,17948],0); -ELEMENTS[31813] = Fluid3D([11419,10463,11006,11160],0); -ELEMENTS[31814] = Fluid3D([10463,11006,11160,10422],0); -ELEMENTS[31815] = Fluid3D([11006,11160,10422,11770],0); -ELEMENTS[31816] = Fluid3D([11419,10463,11160,11775],0); -ELEMENTS[31817] = Fluid3D([11006,11419,11160,12090],0); -ELEMENTS[31818] = Fluid3D([10463,11006,10422,9828],0); -ELEMENTS[31819] = Fluid3D([11160,10463,10422,10264],0); -ELEMENTS[31820] = Fluid3D([10295,9348,9567,9825],0); -ELEMENTS[31821] = Fluid3D([9083,8134,8552,8500],0); -ELEMENTS[31822] = Fluid3D([8134,8552,8500,7509],0); -ELEMENTS[31823] = Fluid3D([8552,9083,8500,9532],0); -ELEMENTS[31824] = Fluid3D([14529,15030,14539,14066],0); -ELEMENTS[31825] = Fluid3D([9681,9081,10241,9858],0); -ELEMENTS[31826] = Fluid3D([12881,12656,12441,11387],0); -ELEMENTS[31827] = Fluid3D([17078,17252,16834,17189],0); -ELEMENTS[31828] = Fluid3D([16834,17078,17189,17100],0); -ELEMENTS[31829] = Fluid3D([17078,17189,17100,17510],0); -ELEMENTS[31830] = Fluid3D([17252,16834,17189,17248],0); -ELEMENTS[31831] = Fluid3D([17078,17252,17189,17510],0); -ELEMENTS[31832] = Fluid3D([6855,6170,6527,6899],0); -ELEMENTS[31833] = Fluid3D([6170,6527,6899,6183],0); -ELEMENTS[31834] = Fluid3D([6855,6170,6899,6713],0); -ELEMENTS[31835] = Fluid3D([6170,6899,6713,6320],0); -ELEMENTS[31836] = Fluid3D([6527,6855,6899,7647],0); -ELEMENTS[31837] = Fluid3D([6899,6713,6320,7401],0); -ELEMENTS[31838] = Fluid3D([6170,6899,6320,6183],0); -ELEMENTS[31839] = Fluid3D([6527,6899,6183,6901],0); -ELEMENTS[31840] = Fluid3D([6170,6527,6183,5704],0); -ELEMENTS[31841] = Fluid3D([6855,6170,6713,6190],0); -ELEMENTS[31842] = Fluid3D([6713,6170,6320,5811],0); -ELEMENTS[31843] = Fluid3D([6899,6855,6713,7516],0); -ELEMENTS[31844] = Fluid3D([6855,6713,7516,7243],0); -ELEMENTS[31845] = Fluid3D([6899,6855,7516,7647],0); -ELEMENTS[31846] = Fluid3D([6855,7516,7647,7917],0); -ELEMENTS[31847] = Fluid3D([7516,7647,7917,8343],0); -ELEMENTS[31848] = Fluid3D([7516,7647,8343,7737],0); -ELEMENTS[31849] = Fluid3D([7516,7647,7737,6899],0); -ELEMENTS[31850] = Fluid3D([8343,7516,7737,7790],0); -ELEMENTS[31851] = Fluid3D([7917,7516,8343,8121],0); -ELEMENTS[31852] = Fluid3D([7737,7516,6899,7401],0); -ELEMENTS[31853] = Fluid3D([7647,8343,7737,8779],0); -ELEMENTS[31854] = Fluid3D([8343,7516,7790,8121],0); -ELEMENTS[31855] = Fluid3D([6713,6899,7516,7401],0); -ELEMENTS[31856] = Fluid3D([6713,7516,7243,6955],0); -ELEMENTS[31857] = Fluid3D([7243,6713,6955,6796],0); -ELEMENTS[31858] = Fluid3D([6713,7516,6955,7401],0); -ELEMENTS[31859] = Fluid3D([3717,3406,3534,3801],0); -ELEMENTS[31860] = Fluid3D([14137,13415,14033,14061],0); -ELEMENTS[31861] = Fluid3D([13415,14033,14061,13596],0); -ELEMENTS[31862] = Fluid3D([14137,13415,14061,13445],0); -ELEMENTS[31863] = Fluid3D([14033,14137,14061,14715],0); -ELEMENTS[31864] = Fluid3D([14137,14061,14715,13445],0); -ELEMENTS[31865] = Fluid3D([14299,14029,13528,13698],0); -ELEMENTS[31866] = Fluid3D([16655,16826,17087,17097],0); -ELEMENTS[31867] = Fluid3D([4047,4491,4212,4040],0); -ELEMENTS[31868] = Fluid3D([9508,9483,9036,8833],0); -ELEMENTS[31869] = Fluid3D([9483,9036,8833,8739],0); -ELEMENTS[31870] = Fluid3D([9036,9508,8833,8604],0); -ELEMENTS[31871] = Fluid3D([9508,9483,8833,9822],0); -ELEMENTS[31872] = Fluid3D([11037,11392,10381,11203],0); -ELEMENTS[31873] = Fluid3D([13227,13238,12749,12176],0); -ELEMENTS[31874] = Fluid3D([3501,3288,3245,3771],0); -ELEMENTS[31875] = Fluid3D([3501,3288,3771,3334],0); -ELEMENTS[31876] = Fluid3D([7615,7465,6868,7572],0); -ELEMENTS[31877] = Fluid3D([7188,6390,6805,6978],0); -ELEMENTS[31878] = Fluid3D([9790,8685,9068,8959],0); -ELEMENTS[31879] = Fluid3D([16242,16627,16255,16653],0); -ELEMENTS[31880] = Fluid3D([4899,5020,5005,4464],0); -ELEMENTS[31881] = Fluid3D([7899,7502,8153,8618],0); -ELEMENTS[31882] = Fluid3D([13557,14293,14290,13928],0); -ELEMENTS[31883] = Fluid3D([10037,10977,10401,9809],0); -ELEMENTS[31884] = Fluid3D([13331,12683,12450,13072],0); -ELEMENTS[31885] = Fluid3D([3935,3788,3533,3514],0); -ELEMENTS[31886] = Fluid3D([3788,3533,3514,3375],0); -ELEMENTS[31887] = Fluid3D([3935,3788,3514,3756],0); -ELEMENTS[31888] = Fluid3D([3788,3514,3756,3863],0); -ELEMENTS[31889] = Fluid3D([3533,3935,3514,3520],0); -ELEMENTS[31890] = Fluid3D([3514,3533,3520,3132],0); -ELEMENTS[31891] = Fluid3D([3514,3756,3863,3247],0); -ELEMENTS[31892] = Fluid3D([4243,3907,4103,4068],0); -ELEMENTS[31893] = Fluid3D([3133,3147,2820,2762],0); -ELEMENTS[31894] = Fluid3D([8425,8543,9279,8847],0); -ELEMENTS[31895] = Fluid3D([13427,14049,13413,12849],0); -ELEMENTS[31896] = Fluid3D([14455,13657,13825,13860],0); -ELEMENTS[31897] = Fluid3D([5787,6157,5713,5743],0); -ELEMENTS[31898] = Fluid3D([11172,11259,11505,12108],0); -ELEMENTS[31899] = Fluid3D([11505,11172,12108,12048],0); -ELEMENTS[31900] = Fluid3D([11172,12108,12048,12280],0); -ELEMENTS[31901] = Fluid3D([12108,12048,12280,12916],0); -ELEMENTS[31902] = Fluid3D([12280,12108,12916,12708],0); -ELEMENTS[31903] = Fluid3D([12280,12108,12708,11259],0); -ELEMENTS[31904] = Fluid3D([12108,12048,12916,12172],0); -ELEMENTS[31905] = Fluid3D([12108,12916,12708,12453],0); -ELEMENTS[31906] = Fluid3D([12916,12280,12708,13226],0); -ELEMENTS[31907] = Fluid3D([12280,12708,13226,13098],0); -ELEMENTS[31908] = Fluid3D([12916,12280,13226,13017],0); -ELEMENTS[31909] = Fluid3D([13226,12916,13017,13950],0); -ELEMENTS[31910] = Fluid3D([12708,12916,13226,13344],0); -ELEMENTS[31911] = Fluid3D([11172,11259,12108,12280],0); -ELEMENTS[31912] = Fluid3D([11259,11505,12108,12453],0); -ELEMENTS[31913] = Fluid3D([12553,13188,12145,13158],0); -ELEMENTS[31914] = Fluid3D([13095,13930,13811,13435],0); -ELEMENTS[31915] = Fluid3D([11762,12552,12233,12737],0); -ELEMENTS[31916] = Fluid3D([6624,7076,6993,7030],0); -ELEMENTS[31917] = Fluid3D([6624,7076,7030,6097],0); -ELEMENTS[31918] = Fluid3D([8804,9359,9664,9330],0); -ELEMENTS[31919] = Fluid3D([9664,8804,9330,9433],0); -ELEMENTS[31920] = Fluid3D([7817,7898,8511,8552],0); -ELEMENTS[31921] = Fluid3D([15678,15648,15360,16139],0); -ELEMENTS[31922] = Fluid3D([14363,14666,15049,15370],0); -ELEMENTS[31923] = Fluid3D([10365,9717,10714,10184],0); -ELEMENTS[31924] = Fluid3D([15706,15153,15801,14982],0); -ELEMENTS[31925] = Fluid3D([17056,17408,16934,16793],0); -ELEMENTS[31926] = Fluid3D([3965,3682,3549,3684],0); -ELEMENTS[31927] = Fluid3D([11256,11689,12203,11668],0); -ELEMENTS[31928] = Fluid3D([11228,11184,10560,11821],0); -ELEMENTS[31929] = Fluid3D([8723,8470,9262,7895],0); -ELEMENTS[31930] = Fluid3D([13897,13496,13328,13981],0); -ELEMENTS[31931] = Fluid3D([18009,18246,18191,18016],0); -ELEMENTS[31932] = Fluid3D([7612,7333,7213,6534],0); -ELEMENTS[31933] = Fluid3D([8007,8329,7871,7447],0); -ELEMENTS[31934] = Fluid3D([8329,7871,7447,7786],0); -ELEMENTS[31935] = Fluid3D([7871,8007,7447,6910],0); -ELEMENTS[31936] = Fluid3D([8007,8329,7447,8219],0); -ELEMENTS[31937] = Fluid3D([4637,5192,4958,5358],0); -ELEMENTS[31938] = Fluid3D([17114,16567,16756,16992],0); -ELEMENTS[31939] = Fluid3D([5864,5318,5854,5323],0); -ELEMENTS[31940] = Fluid3D([13539,13871,12883,13203],0); -ELEMENTS[31941] = Fluid3D([13871,12883,13203,12837],0); -ELEMENTS[31942] = Fluid3D([13539,13871,13203,13660],0); -ELEMENTS[31943] = Fluid3D([17198,16916,17084,17240],0); -ELEMENTS[31944] = Fluid3D([12879,13297,13046,12733],0); -ELEMENTS[31945] = Fluid3D([13297,13046,12733,13141],0); -ELEMENTS[31946] = Fluid3D([12879,13297,12733,12650],0); -ELEMENTS[31947] = Fluid3D([12733,12879,12650,12035],0); -ELEMENTS[31948] = Fluid3D([12879,12650,12035,12582],0); -ELEMENTS[31949] = Fluid3D([13046,12879,12733,12035],0); -ELEMENTS[31950] = Fluid3D([12879,13297,12650,13711],0); -ELEMENTS[31951] = Fluid3D([12650,12879,13711,13055],0); -ELEMENTS[31952] = Fluid3D([12650,12879,13055,12582],0); -ELEMENTS[31953] = Fluid3D([15793,16064,15640,15500],0); -ELEMENTS[31954] = Fluid3D([16064,15640,15500,15772],0); -ELEMENTS[31955] = Fluid3D([15793,16064,15500,15938],0); -ELEMENTS[31956] = Fluid3D([15640,15793,15500,15181],0); -ELEMENTS[31957] = Fluid3D([4286,4827,4567,4976],0); -ELEMENTS[31958] = Fluid3D([4827,4567,4976,4956],0); -ELEMENTS[31959] = Fluid3D([15650,16232,16122,15949],0); -ELEMENTS[31960] = Fluid3D([15650,16232,15949,15709],0); -ELEMENTS[31961] = Fluid3D([16122,15650,15949,15354],0); -ELEMENTS[31962] = Fluid3D([16232,16122,15949,16518],0); -ELEMENTS[31963] = Fluid3D([15949,16232,16518,16205],0); -ELEMENTS[31964] = Fluid3D([16232,16518,16205,16761],0); -ELEMENTS[31965] = Fluid3D([16232,16122,16518,16583],0); -ELEMENTS[31966] = Fluid3D([15949,16232,16205,15709],0); -ELEMENTS[31967] = Fluid3D([16518,15949,16205,16409],0); -ELEMENTS[31968] = Fluid3D([16518,15949,16409,16175],0); -ELEMENTS[31969] = Fluid3D([15949,16205,16409,15774],0); -ELEMENTS[31970] = Fluid3D([16409,15949,15774,15670],0); -ELEMENTS[31971] = Fluid3D([15949,15774,15670,15056],0); -ELEMENTS[31972] = Fluid3D([16409,15949,15670,16175],0); -ELEMENTS[31973] = Fluid3D([15949,15670,16175,15354],0); -ELEMENTS[31974] = Fluid3D([16409,16518,16175,16697],0); -ELEMENTS[31975] = Fluid3D([16409,16518,16697,16921],0); -ELEMENTS[31976] = Fluid3D([16518,16697,16921,16863],0); -ELEMENTS[31977] = Fluid3D([16921,16518,16863,16583],0); -ELEMENTS[31978] = Fluid3D([16175,16409,16697,16106],0); -ELEMENTS[31979] = Fluid3D([16205,16518,16409,16792],0); -ELEMENTS[31980] = Fluid3D([16409,16205,16792,16479],0); -ELEMENTS[31981] = Fluid3D([16518,16409,16792,16921],0); -ELEMENTS[31982] = Fluid3D([16792,16518,16921,16788],0); -ELEMENTS[31983] = Fluid3D([16518,16921,16788,16761],0); -ELEMENTS[31984] = Fluid3D([16921,16788,16761,17079],0); -ELEMENTS[31985] = Fluid3D([16788,16761,17079,16849],0); -ELEMENTS[31986] = Fluid3D([16788,16761,16849,16473],0); -ELEMENTS[31987] = Fluid3D([17079,16788,16849,16792],0); -ELEMENTS[31988] = Fluid3D([16788,16761,16473,16205],0); -ELEMENTS[31989] = Fluid3D([16849,16788,16473,16205],0); -ELEMENTS[31990] = Fluid3D([16761,16849,16473,16800],0); -ELEMENTS[31991] = Fluid3D([16761,17079,16849,17065],0); -ELEMENTS[31992] = Fluid3D([16788,16518,16761,16205],0); -ELEMENTS[31993] = Fluid3D([16921,16788,17079,16792],0); -ELEMENTS[31994] = Fluid3D([16473,16849,16205,16521],0); -ELEMENTS[31995] = Fluid3D([16473,16849,16521,16662],0); -ELEMENTS[31996] = Fluid3D([16205,16473,16521,15990],0); -ELEMENTS[31997] = Fluid3D([16473,16521,15990,16345],0); -ELEMENTS[31998] = Fluid3D([16473,16521,16345,16662],0); -ELEMENTS[31999] = Fluid3D([16521,16345,16662,16244],0); -ELEMENTS[32000] = Fluid3D([15990,16473,16345,16079],0); -ELEMENTS[32001] = Fluid3D([16205,16473,15990,16232],0); -ELEMENTS[32002] = Fluid3D([15990,16473,16079,16232],0); -ELEMENTS[32003] = Fluid3D([16473,16345,16079,16800],0); -ELEMENTS[32004] = Fluid3D([16792,16518,16788,16205],0); -ELEMENTS[32005] = Fluid3D([16521,15990,16345,16244],0); -ELEMENTS[32006] = Fluid3D([16345,15990,16079,15741],0); -ELEMENTS[32007] = Fluid3D([15990,16079,15741,15709],0); -ELEMENTS[32008] = Fluid3D([15990,16079,15709,16232],0); -ELEMENTS[32009] = Fluid3D([16079,16345,15741,16117],0); -ELEMENTS[32010] = Fluid3D([16079,16345,16117,16800],0); -ELEMENTS[32011] = Fluid3D([15741,16079,16117,15314],0); -ELEMENTS[32012] = Fluid3D([16345,15741,16117,16144],0); -ELEMENTS[32013] = Fluid3D([16345,15741,16144,16244],0); -ELEMENTS[32014] = Fluid3D([16117,16345,16144,16585],0); -ELEMENTS[32015] = Fluid3D([16117,16345,16585,16800],0); -ELEMENTS[32016] = Fluid3D([16345,16144,16585,16662],0); -ELEMENTS[32017] = Fluid3D([16345,16144,16662,16244],0); -ELEMENTS[32018] = Fluid3D([16585,16345,16662,17039],0); -ELEMENTS[32019] = Fluid3D([16345,15990,15741,16244],0); -ELEMENTS[32020] = Fluid3D([15949,16205,15774,15709],0); -ELEMENTS[32021] = Fluid3D([16792,16409,16479,16719],0); -ELEMENTS[32022] = Fluid3D([16792,16409,16719,16697],0); -ELEMENTS[32023] = Fluid3D([16479,16792,16719,16987],0); -ELEMENTS[32024] = Fluid3D([16409,16479,16719,16206],0); -ELEMENTS[32025] = Fluid3D([16792,16719,16987,17293],0); -ELEMENTS[32026] = Fluid3D([16409,16479,16206,15774],0); -ELEMENTS[32027] = Fluid3D([16719,16409,16206,16361],0); -ELEMENTS[32028] = Fluid3D([16206,16719,16361,16717],0); -ELEMENTS[32029] = Fluid3D([16719,16409,16361,16697],0); -ELEMENTS[32030] = Fluid3D([16409,16206,16361,15824],0); -ELEMENTS[32031] = Fluid3D([16206,16361,15824,16295],0); -ELEMENTS[32032] = Fluid3D([16361,15824,16295,16106],0); -ELEMENTS[32033] = Fluid3D([16295,16361,16106,16750],0); -ELEMENTS[32034] = Fluid3D([16295,16361,16750,16717],0); -ELEMENTS[32035] = Fluid3D([16361,15824,16106,16409],0); -ELEMENTS[32036] = Fluid3D([16106,16361,16409,16697],0); -ELEMENTS[32037] = Fluid3D([16206,16361,16295,16717],0); -ELEMENTS[32038] = Fluid3D([16361,16106,16750,16697],0); -ELEMENTS[32039] = Fluid3D([16409,16205,16479,15774],0); -ELEMENTS[32040] = Fluid3D([16479,16792,16987,16808],0); -ELEMENTS[32041] = Fluid3D([16479,16792,16808,16205],0); -ELEMENTS[32042] = Fluid3D([16987,16479,16808,16714],0); -ELEMENTS[32043] = Fluid3D([16792,16987,16808,17201],0); -ELEMENTS[32044] = Fluid3D([16792,16987,17201,17293],0); -ELEMENTS[32045] = Fluid3D([16479,16808,16714,16521],0); -ELEMENTS[32046] = Fluid3D([16808,16714,16521,17110],0); -ELEMENTS[32047] = Fluid3D([16479,16808,16521,16205],0); -ELEMENTS[32048] = Fluid3D([16808,16521,16205,16849],0); -ELEMENTS[32049] = Fluid3D([16808,16521,16849,17110],0); -ELEMENTS[32050] = Fluid3D([16987,16808,17201,17193],0); -ELEMENTS[32051] = Fluid3D([16987,16479,16714,16686],0); -ELEMENTS[32052] = Fluid3D([16714,16987,16686,17272],0); -ELEMENTS[32053] = Fluid3D([16987,16479,16686,16719],0); -ELEMENTS[32054] = Fluid3D([16479,16714,16686,16259],0); -ELEMENTS[32055] = Fluid3D([16714,16686,16259,16851],0); -ELEMENTS[32056] = Fluid3D([16714,16686,16851,17272],0); -ELEMENTS[32057] = Fluid3D([16259,16714,16851,16343],0); -ELEMENTS[32058] = Fluid3D([16714,16851,16343,16742],0); -ELEMENTS[32059] = Fluid3D([16714,16851,16742,17193],0); -ELEMENTS[32060] = Fluid3D([16714,16851,17193,17272],0); -ELEMENTS[32061] = Fluid3D([16742,16714,17193,17110],0); -ELEMENTS[32062] = Fluid3D([16343,16714,16742,16314],0); -ELEMENTS[32063] = Fluid3D([16714,16742,16314,16521],0); -ELEMENTS[32064] = Fluid3D([16742,16314,16521,16244],0); -ELEMENTS[32065] = Fluid3D([16314,16521,16244,15990],0); -ELEMENTS[32066] = Fluid3D([16314,16521,15990,16205],0); -ELEMENTS[32067] = Fluid3D([16314,16714,16521,16479],0); -ELEMENTS[32068] = Fluid3D([16714,16742,16521,17110],0); -ELEMENTS[32069] = Fluid3D([16742,16314,16244,16343],0); -ELEMENTS[32070] = Fluid3D([16479,16714,16259,16314],0); -ELEMENTS[32071] = Fluid3D([16714,16259,16314,16343],0); -ELEMENTS[32072] = Fluid3D([16259,16479,16314,15774],0); -ELEMENTS[32073] = Fluid3D([16686,16479,16259,16206],0); -ELEMENTS[32074] = Fluid3D([16808,16792,17201,17079],0); -ELEMENTS[32075] = Fluid3D([16122,15949,16518,16175],0); -ELEMENTS[32076] = Fluid3D([16808,16987,16714,17193],0); -ELEMENTS[32077] = Fluid3D([16518,16175,16697,16445],0); -ELEMENTS[32078] = Fluid3D([16479,16719,16206,16686],0); -ELEMENTS[32079] = Fluid3D([3116,3374,3404,3600],0); -ELEMENTS[32080] = Fluid3D([11554,11552,10686,11232],0); -ELEMENTS[32081] = Fluid3D([8066,8306,8815,8686],0); -ELEMENTS[32082] = Fluid3D([8815,8066,8686,9179],0); -ELEMENTS[32083] = Fluid3D([11079,10361,10699,11070],0); -ELEMENTS[32084] = Fluid3D([6659,6086,6156,6664],0); -ELEMENTS[32085] = Fluid3D([6659,6086,6664,6749],0); -ELEMENTS[32086] = Fluid3D([6086,6664,6749,6298],0); -ELEMENTS[32087] = Fluid3D([6086,6156,6664,5985],0); -ELEMENTS[32088] = Fluid3D([6664,6086,5985,6298],0); -ELEMENTS[32089] = Fluid3D([6086,6156,5985,5508],0); -ELEMENTS[32090] = Fluid3D([14226,14171,13768,14597],0); -ELEMENTS[32091] = Fluid3D([14226,14171,14597,15092],0); -ELEMENTS[32092] = Fluid3D([14171,13768,14597,14565],0); -ELEMENTS[32093] = Fluid3D([13768,14597,14565,14348],0); -ELEMENTS[32094] = Fluid3D([14597,14565,14348,15007],0); -ELEMENTS[32095] = Fluid3D([14565,14348,15007,14298],0); -ELEMENTS[32096] = Fluid3D([14348,15007,14298,14572],0); -ELEMENTS[32097] = Fluid3D([14298,14348,14572,13471],0); -ELEMENTS[32098] = Fluid3D([14565,14348,14298,13768],0); -ELEMENTS[32099] = Fluid3D([14348,15007,14572,14437],0); -ELEMENTS[32100] = Fluid3D([14348,14597,15007,15360],0); -ELEMENTS[32101] = Fluid3D([14597,14171,14565,15092],0); -ELEMENTS[32102] = Fluid3D([14565,14597,15092,15007],0); -ELEMENTS[32103] = Fluid3D([14597,15092,15007,15360],0); -ELEMENTS[32104] = Fluid3D([14348,14298,13768,13471],0); -ELEMENTS[32105] = Fluid3D([15007,14298,14572,15209],0); -ELEMENTS[32106] = Fluid3D([13768,14597,14348,14226],0); -ELEMENTS[32107] = Fluid3D([5017,4867,5093,5479],0); -ELEMENTS[32108] = Fluid3D([13760,13392,12958,13749],0); -ELEMENTS[32109] = Fluid3D([12728,12239,12633,11956],0); -ELEMENTS[32110] = Fluid3D([12728,12239,11956,11554],0); -ELEMENTS[32111] = Fluid3D([11124,10703,11709,11016],0); -ELEMENTS[32112] = Fluid3D([5460,5546,5917,5043],0); -ELEMENTS[32113] = Fluid3D([13637,14222,13818,14604],0); -ELEMENTS[32114] = Fluid3D([14351,15105,14858,14808],0); -ELEMENTS[32115] = Fluid3D([5643,6270,6084,6375],0); -ELEMENTS[32116] = Fluid3D([5857,6040,5390,5594],0); -ELEMENTS[32117] = Fluid3D([6040,5390,5594,5823],0); -ELEMENTS[32118] = Fluid3D([2517,2475,2269,2381],0); -ELEMENTS[32119] = Fluid3D([2475,2269,2381,2234],0); -ELEMENTS[32120] = Fluid3D([9098,9552,8683,9175],0); -ELEMENTS[32121] = Fluid3D([18371,18399,18212,18432],0); -ELEMENTS[32122] = Fluid3D([18399,18212,18432,18401],0); -ELEMENTS[32123] = Fluid3D([18212,18432,18401,18351],0); -ELEMENTS[32124] = Fluid3D([18432,18401,18351,18516],0); -ELEMENTS[32125] = Fluid3D([18432,18401,18516,18542],0); -ELEMENTS[32126] = Fluid3D([18351,18432,18516,18371],0); -ELEMENTS[32127] = Fluid3D([18351,18432,18371,18212],0); -ELEMENTS[32128] = Fluid3D([18516,18432,18542,18518],0); -ELEMENTS[32129] = Fluid3D([18432,18401,18542,18518],0); -ELEMENTS[32130] = Fluid3D([18432,18516,18371,18535],0); -ELEMENTS[32131] = Fluid3D([18432,18516,18535,18518],0); -ELEMENTS[32132] = Fluid3D([18371,18399,18432,18535],0); -ELEMENTS[32133] = Fluid3D([4718,5058,4466,4779],0); -ELEMENTS[32134] = Fluid3D([9226,9823,9725,8977],0); -ELEMENTS[32135] = Fluid3D([14981,15156,15239,15676],0); -ELEMENTS[32136] = Fluid3D([16726,16822,16368,16570],0); -ELEMENTS[32137] = Fluid3D([10242,10637,11233,10976],0); -ELEMENTS[32138] = Fluid3D([15649,15935,15643,16235],0); -ELEMENTS[32139] = Fluid3D([6039,5431,5997,5664],0); -ELEMENTS[32140] = Fluid3D([8909,8000,8322,8402],0); -ELEMENTS[32141] = Fluid3D([11703,11690,11189,12388],0); -ELEMENTS[32142] = Fluid3D([10434,9678,9471,10459],0); -ELEMENTS[32143] = Fluid3D([12472,11908,12421,11229],0); -ELEMENTS[32144] = Fluid3D([12554,12588,12706,11978],0); -ELEMENTS[32145] = Fluid3D([12588,12706,11978,12702],0); -ELEMENTS[32146] = Fluid3D([16423,16658,16162,16831],0); -ELEMENTS[32147] = Fluid3D([11091,10774,10359,10135],0); -ELEMENTS[32148] = Fluid3D([10068,10960,11002,10712],0); -ELEMENTS[32149] = Fluid3D([11320,11121,11489,10458],0); -ELEMENTS[32150] = Fluid3D([13586,12491,13287,12803],0); -ELEMENTS[32151] = Fluid3D([15435,15210,15045,14643],0); -ELEMENTS[32152] = Fluid3D([10962,10941,11523,10542],0); -ELEMENTS[32153] = Fluid3D([5482,5982,6117,5622],0); -ELEMENTS[32154] = Fluid3D([2943,3052,2713,2770],0); -ELEMENTS[32155] = Fluid3D([16057,16182,15686,16430],0); -ELEMENTS[32156] = Fluid3D([17304,17056,16934,16723],0); -ELEMENTS[32157] = Fluid3D([10847,10181,10951,11007],0); -ELEMENTS[32158] = Fluid3D([10228,11380,10754,10602],0); -ELEMENTS[32159] = Fluid3D([10754,10228,10602,9886],0); -ELEMENTS[32160] = Fluid3D([10228,10602,9886,10809],0); -ELEMENTS[32161] = Fluid3D([10228,11380,10602,10809],0); -ELEMENTS[32162] = Fluid3D([11380,10754,10602,11546],0); -ELEMENTS[32163] = Fluid3D([10602,11380,11546,10746],0); -ELEMENTS[32164] = Fluid3D([10754,10602,11546,10567],0); -ELEMENTS[32165] = Fluid3D([10754,10602,10567,9886],0); -ELEMENTS[32166] = Fluid3D([11546,10754,10567,11313],0); -ELEMENTS[32167] = Fluid3D([10602,10567,9886,10384],0); -ELEMENTS[32168] = Fluid3D([10602,11546,10567,10384],0); -ELEMENTS[32169] = Fluid3D([9886,10602,10384,10746],0); -ELEMENTS[32170] = Fluid3D([9886,10602,10746,10809],0); -ELEMENTS[32171] = Fluid3D([10602,10746,10809,11380],0); -ELEMENTS[32172] = Fluid3D([11380,10754,11546,11974],0); -ELEMENTS[32173] = Fluid3D([13158,13470,13973,13683],0); -ELEMENTS[32174] = Fluid3D([13470,13973,13683,14306],0); -ELEMENTS[32175] = Fluid3D([8413,7858,8622,8042],0); -ELEMENTS[32176] = Fluid3D([12473,12233,13139,12737],0); -ELEMENTS[32177] = Fluid3D([3644,3273,3800,3353],0); -ELEMENTS[32178] = Fluid3D([9225,8766,9745,10073],0); -ELEMENTS[32179] = Fluid3D([8916,8779,8686,8343],0); -ELEMENTS[32180] = Fluid3D([8686,8916,8343,7790],0); -ELEMENTS[32181] = Fluid3D([8916,8779,8343,8615],0); -ELEMENTS[32182] = Fluid3D([8779,8686,8343,7737],0); -ELEMENTS[32183] = Fluid3D([8686,8343,7737,7790],0); -ELEMENTS[32184] = Fluid3D([8779,8343,8615,7647],0); -ELEMENTS[32185] = Fluid3D([8343,8916,8615,7917],0); -ELEMENTS[32186] = Fluid3D([8343,8916,7917,8121],0); -ELEMENTS[32187] = Fluid3D([4431,3996,4145,3876],0); -ELEMENTS[32188] = Fluid3D([9992,9533,9609,10303],0); -ELEMENTS[32189] = Fluid3D([14842,14375,14018,14393],0); -ELEMENTS[32190] = Fluid3D([9036,10135,9722,9502],0); -ELEMENTS[32191] = Fluid3D([6747,6256,5983,6445],0); -ELEMENTS[32192] = Fluid3D([6747,6256,6445,7063],0); -ELEMENTS[32193] = Fluid3D([6256,5983,6445,6059],0); -ELEMENTS[32194] = Fluid3D([5983,6747,6445,6287],0); -ELEMENTS[32195] = Fluid3D([6445,5983,6287,6059],0); -ELEMENTS[32196] = Fluid3D([6287,6445,6059,6804],0); -ELEMENTS[32197] = Fluid3D([6445,6059,6804,6503],0); -ELEMENTS[32198] = Fluid3D([6287,6445,6804,7300],0); -ELEMENTS[32199] = Fluid3D([6287,6445,7300,6747],0); -ELEMENTS[32200] = Fluid3D([6445,6804,7300,7167],0); -ELEMENTS[32201] = Fluid3D([7300,6445,7167,6747],0); -ELEMENTS[32202] = Fluid3D([6445,6804,7167,6503],0); -ELEMENTS[32203] = Fluid3D([8112,8928,7882,8192],0); -ELEMENTS[32204] = Fluid3D([8928,7882,8192,8752],0); -ELEMENTS[32205] = Fluid3D([7882,8112,8192,7234],0); -ELEMENTS[32206] = Fluid3D([8112,8928,8192,8962],0); -ELEMENTS[32207] = Fluid3D([13110,12447,13366,13421],0); -ELEMENTS[32208] = Fluid3D([15247,15559,15217,16077],0); -ELEMENTS[32209] = Fluid3D([14083,13710,13301,13365],0); -ELEMENTS[32210] = Fluid3D([13301,14083,13365,14483],0); -ELEMENTS[32211] = Fluid3D([3599,3538,3542,3212],0); -ELEMENTS[32212] = Fluid3D([3538,3542,3212,3357],0); -ELEMENTS[32213] = Fluid3D([3212,3538,3357,3114],0); -ELEMENTS[32214] = Fluid3D([3542,3599,3212,3244],0); -ELEMENTS[32215] = Fluid3D([3599,3538,3212,3244],0); -ELEMENTS[32216] = Fluid3D([3212,3542,3244,3117],0); -ELEMENTS[32217] = Fluid3D([3538,3212,3244,3114],0); -ELEMENTS[32218] = Fluid3D([3212,3244,3114,2976],0); -ELEMENTS[32219] = Fluid3D([10631,9747,10233,10882],0); -ELEMENTS[32220] = Fluid3D([15712,15878,15294,15974],0); -ELEMENTS[32221] = Fluid3D([10338,11182,11292,10765],0); -ELEMENTS[32222] = Fluid3D([10338,11182,10765,10264],0); -ELEMENTS[32223] = Fluid3D([11182,10765,10264,11775],0); -ELEMENTS[32224] = Fluid3D([10765,10338,10264,9885],0); -ELEMENTS[32225] = Fluid3D([11182,10765,11775,11605],0); -ELEMENTS[32226] = Fluid3D([11182,10765,11605,11292],0); -ELEMENTS[32227] = Fluid3D([5398,5112,5076,5690],0); -ELEMENTS[32228] = Fluid3D([6608,7280,7352,7747],0); -ELEMENTS[32229] = Fluid3D([9535,9584,8672,9316],0); -ELEMENTS[32230] = Fluid3D([8672,9535,9316,8721],0); -ELEMENTS[32231] = Fluid3D([9535,9584,9316,10372],0); -ELEMENTS[32232] = Fluid3D([9584,8672,9316,8859],0); -ELEMENTS[32233] = Fluid3D([15269,15478,15914,15586],0); -ELEMENTS[32234] = Fluid3D([15914,15269,15586,15638],0); -ELEMENTS[32235] = Fluid3D([16247,16099,16614,16436],0); -ELEMENTS[32236] = Fluid3D([15350,15968,15829,15580],0); -ELEMENTS[32237] = Fluid3D([15829,15350,15580,14821],0); -ELEMENTS[32238] = Fluid3D([3698,3739,4102,3595],0); -ELEMENTS[32239] = Fluid3D([9414,8470,8796,8962],0); -ELEMENTS[32240] = Fluid3D([12357,11878,11383,11619],0); -ELEMENTS[32241] = Fluid3D([13794,13593,13146,12907],0); -ELEMENTS[32242] = Fluid3D([17967,18215,18122,18139],0); -ELEMENTS[32243] = Fluid3D([10473,10640,10859,11204],0); -ELEMENTS[32244] = Fluid3D([18011,17832,17876,18232],0); -ELEMENTS[32245] = Fluid3D([13246,12649,12367,12600],0); -ELEMENTS[32246] = Fluid3D([13246,12649,12600,12960],0); -ELEMENTS[32247] = Fluid3D([12367,13246,12600,12784],0); -ELEMENTS[32248] = Fluid3D([12649,12367,12600,12131],0); -ELEMENTS[32249] = Fluid3D([12367,12600,12131,11888],0); -ELEMENTS[32250] = Fluid3D([12600,12131,11888,12203],0); -ELEMENTS[32251] = Fluid3D([12131,12367,11888,11536],0); -ELEMENTS[32252] = Fluid3D([12367,12600,11888,12784],0); -ELEMENTS[32253] = Fluid3D([12600,11888,12784,12203],0); -ELEMENTS[32254] = Fluid3D([12131,12367,11536,11857],0); -ELEMENTS[32255] = Fluid3D([11888,12131,11536,10908],0); -ELEMENTS[32256] = Fluid3D([12367,11888,11536,11300],0); -ELEMENTS[32257] = Fluid3D([12131,11888,12203,11256],0); -ELEMENTS[32258] = Fluid3D([12600,12649,12131,12203],0); -ELEMENTS[32259] = Fluid3D([12649,12367,12131,11857],0); -ELEMENTS[32260] = Fluid3D([12784,12600,12203,12960],0); -ELEMENTS[32261] = Fluid3D([12784,12600,12960,13356],0); -ELEMENTS[32262] = Fluid3D([12784,12600,13356,13246],0); -ELEMENTS[32263] = Fluid3D([12600,12203,12960,12649],0); -ELEMENTS[32264] = Fluid3D([12600,13356,13246,12960],0); -ELEMENTS[32265] = Fluid3D([12203,12784,12960,12753],0); -ELEMENTS[32266] = Fluid3D([12367,11536,11857,12409],0); -ELEMENTS[32267] = Fluid3D([12131,11888,11256,10908],0); -ELEMENTS[32268] = Fluid3D([10370,9647,9659,10454],0); -ELEMENTS[32269] = Fluid3D([17052,17147,17384,17374],0); -ELEMENTS[32270] = Fluid3D([15507,15910,15537,15254],0); -ELEMENTS[32271] = Fluid3D([14181,14441,14834,13940],0); -ELEMENTS[32272] = Fluid3D([3169,3172,2949,3473],0); -ELEMENTS[32273] = Fluid3D([17217,16900,17014,17469],0); -ELEMENTS[32274] = Fluid3D([11132,10737,11699,10920],0); -ELEMENTS[32275] = Fluid3D([11311,11048,10773,11755],0); -ELEMENTS[32276] = Fluid3D([7254,7109,6715,7780],0); -ELEMENTS[32277] = Fluid3D([15135,15145,14811,15841],0); -ELEMENTS[32278] = Fluid3D([8574,7699,8302,7995],0); -ELEMENTS[32279] = Fluid3D([7699,8302,7995,7364],0); -ELEMENTS[32280] = Fluid3D([7995,7699,7364,7372],0); -ELEMENTS[32281] = Fluid3D([7699,7364,7372,6835],0); -ELEMENTS[32282] = Fluid3D([7364,7995,7372,7107],0); -ELEMENTS[32283] = Fluid3D([8302,7995,7364,8415],0); -ELEMENTS[32284] = Fluid3D([7699,8302,7364,7581],0); -ELEMENTS[32285] = Fluid3D([7364,7995,7107,8415],0); -ELEMENTS[32286] = Fluid3D([8629,8487,7910,8786],0); -ELEMENTS[32287] = Fluid3D([8487,7910,8786,8124],0); -ELEMENTS[32288] = Fluid3D([8629,8487,8786,9289],0); -ELEMENTS[32289] = Fluid3D([8487,8786,9289,8124],0); -ELEMENTS[32290] = Fluid3D([7910,8629,8786,8469],0); -ELEMENTS[32291] = Fluid3D([5753,6340,6112,5687],0); -ELEMENTS[32292] = Fluid3D([10050,9958,10912,10130],0); -ELEMENTS[32293] = Fluid3D([6626,5967,6602,6315],0); -ELEMENTS[32294] = Fluid3D([14492,13778,13792,14018],0); -ELEMENTS[32295] = Fluid3D([7868,8536,8176,9073],0); -ELEMENTS[32296] = Fluid3D([16339,16728,16760,16864],0); -ELEMENTS[32297] = Fluid3D([14720,14339,14992,15440],0); -ELEMENTS[32298] = Fluid3D([15996,16096,16468,15847],0); -ELEMENTS[32299] = Fluid3D([16468,15996,15847,16252],0); -ELEMENTS[32300] = Fluid3D([15996,15847,16252,15473],0); -ELEMENTS[32301] = Fluid3D([15996,15847,15473,15407],0); -ELEMENTS[32302] = Fluid3D([15996,16096,15847,15407],0); -ELEMENTS[32303] = Fluid3D([12986,13566,12987,12382],0); -ELEMENTS[32304] = Fluid3D([6004,6949,6540,6822],0); -ELEMENTS[32305] = Fluid3D([6004,6949,6822,6137],0); -ELEMENTS[32306] = Fluid3D([6540,6004,6822,6254],0); -ELEMENTS[32307] = Fluid3D([6004,6822,6254,5790],0); -ELEMENTS[32308] = Fluid3D([6822,6540,6254,7055],0); -ELEMENTS[32309] = Fluid3D([6254,6822,7055,7089],0); -ELEMENTS[32310] = Fluid3D([7055,6254,7089,7104],0); -ELEMENTS[32311] = Fluid3D([7089,7055,7104,7701],0); -ELEMENTS[32312] = Fluid3D([7055,7104,7701,7566],0); -ELEMENTS[32313] = Fluid3D([7089,7055,7701,6822],0); -ELEMENTS[32314] = Fluid3D([7701,7055,7566,7348],0); -ELEMENTS[32315] = Fluid3D([7701,7055,7348,6822],0); -ELEMENTS[32316] = Fluid3D([7055,7104,7566,6650],0); -ELEMENTS[32317] = Fluid3D([7055,7104,6650,6254],0); -ELEMENTS[32318] = Fluid3D([7055,7348,6822,6540],0); -ELEMENTS[32319] = Fluid3D([7566,7701,7348,8143],0); -ELEMENTS[32320] = Fluid3D([6949,6540,6822,7348],0); -ELEMENTS[32321] = Fluid3D([8841,8471,7928,8584],0); -ELEMENTS[32322] = Fluid3D([9433,10264,10378,9664],0); -ELEMENTS[32323] = Fluid3D([17755,17342,17638,17608],0); -ELEMENTS[32324] = Fluid3D([11488,10982,10400,11244],0); -ELEMENTS[32325] = Fluid3D([8593,8566,7820,8479],0); -ELEMENTS[32326] = Fluid3D([5488,6048,6031,6130],0); -ELEMENTS[32327] = Fluid3D([9353,9482,8706,9642],0); -ELEMENTS[32328] = Fluid3D([13456,13484,14157,14195],0); -ELEMENTS[32329] = Fluid3D([4055,3788,4128,3882],0); -ELEMENTS[32330] = Fluid3D([4128,4055,3882,4251],0); -ELEMENTS[32331] = Fluid3D([4055,3882,4251,4080],0); -ELEMENTS[32332] = Fluid3D([4055,3788,3882,3748],0); -ELEMENTS[32333] = Fluid3D([8586,8437,9329,9384],0); -ELEMENTS[32334] = Fluid3D([13016,13965,13517,13794],0); -ELEMENTS[32335] = Fluid3D([7456,7510,6768,7190],0); -ELEMENTS[32336] = Fluid3D([13528,14246,14023,13390],0); -ELEMENTS[32337] = Fluid3D([4543,5002,4811,4844],0); -ELEMENTS[32338] = Fluid3D([4811,4543,4844,4206],0); -ELEMENTS[32339] = Fluid3D([17627,17257,17568,17753],0); -ELEMENTS[32340] = Fluid3D([9770,9974,10403,9266],0); -ELEMENTS[32341] = Fluid3D([12145,11285,11987,11277],0); -ELEMENTS[32342] = Fluid3D([11366,11399,11807,10540],0); -ELEMENTS[32343] = Fluid3D([8650,8388,8132,7578],0); -ELEMENTS[32344] = Fluid3D([5370,5777,5311,5771],0); -ELEMENTS[32345] = Fluid3D([7413,7803,7291,8342],0); -ELEMENTS[32346] = Fluid3D([3760,3313,3440,3221],0); -ELEMENTS[32347] = Fluid3D([14244,13664,13741,14593],0); -ELEMENTS[32348] = Fluid3D([11314,11540,10557,11969],0); -ELEMENTS[32349] = Fluid3D([17779,17993,17773,18055],0); -ELEMENTS[32350] = Fluid3D([12118,12920,13000,12577],0); -ELEMENTS[32351] = Fluid3D([6838,6811,7315,6212],0); -ELEMENTS[32352] = Fluid3D([7524,8051,7329,7517],0); -ELEMENTS[32353] = Fluid3D([8788,8547,9475,9130],0); -ELEMENTS[32354] = Fluid3D([13308,12935,12500,13680],0); -ELEMENTS[32355] = Fluid3D([14437,14656,15093,15306],0); -ELEMENTS[32356] = Fluid3D([14656,15093,15306,15294],0); -ELEMENTS[32357] = Fluid3D([15093,14437,15306,15360],0); -ELEMENTS[32358] = Fluid3D([15306,15093,15360,15667],0); -ELEMENTS[32359] = Fluid3D([7854,8698,8089,8042],0); -ELEMENTS[32360] = Fluid3D([16670,16486,16176,16362],0); -ELEMENTS[32361] = Fluid3D([5897,6386,6667,6641],0); -ELEMENTS[32362] = Fluid3D([13755,14166,13279,13866],0); -ELEMENTS[32363] = Fluid3D([15531,15514,15178,15947],0); -ELEMENTS[32364] = Fluid3D([5747,6001,6360,6571],0); -ELEMENTS[32365] = Fluid3D([4448,3956,4425,3992],0); -ELEMENTS[32366] = Fluid3D([10304,11177,10829,11345],0); -ELEMENTS[32367] = Fluid3D([6977,6766,6619,6044],0); -ELEMENTS[32368] = Fluid3D([11473,11095,10474,10552],0); -ELEMENTS[32369] = Fluid3D([14721,15429,15137,15082],0); -ELEMENTS[32370] = Fluid3D([11653,11136,10613,11205],0); -ELEMENTS[32371] = Fluid3D([10377,9682,9788,10705],0); -ELEMENTS[32372] = Fluid3D([15224,15402,15751,14949],0); -ELEMENTS[32373] = Fluid3D([16891,16802,16771,16335],0); -ELEMENTS[32374] = Fluid3D([5990,6755,6239,6250],0); -ELEMENTS[32375] = Fluid3D([9208,10082,9917,10470],0); -ELEMENTS[32376] = Fluid3D([11838,11428,12481,12245],0); -ELEMENTS[32377] = Fluid3D([14414,14208,14285,15048],0); -ELEMENTS[32378] = Fluid3D([18165,17890,18072,17983],0); -ELEMENTS[32379] = Fluid3D([17890,18072,17983,17627],0); -ELEMENTS[32380] = Fluid3D([8877,9207,8649,8209],0); -ELEMENTS[32381] = Fluid3D([3646,3873,3699,3223],0); -ELEMENTS[32382] = Fluid3D([4474,4202,4343,4883],0); -ELEMENTS[32383] = Fluid3D([16432,16567,16038,16287],0); -ELEMENTS[32384] = Fluid3D([16432,16567,16287,16756],0); -ELEMENTS[32385] = Fluid3D([16038,16432,16287,15897],0); -ELEMENTS[32386] = Fluid3D([16567,16038,16287,16046],0); -ELEMENTS[32387] = Fluid3D([15805,16218,16126,15396],0); -ELEMENTS[32388] = Fluid3D([9963,10055,10757,10472],0); -ELEMENTS[32389] = Fluid3D([12699,12491,12234,13287],0); -ELEMENTS[32390] = Fluid3D([9616,9024,8852,8194],0); -ELEMENTS[32391] = Fluid3D([5053,4737,5385,4637],0); -ELEMENTS[32392] = Fluid3D([4827,4286,4610,4810],0); -ELEMENTS[32393] = Fluid3D([2899,2841,2858,2517],0); -ELEMENTS[32394] = Fluid3D([13813,13576,13091,13922],0); -ELEMENTS[32395] = Fluid3D([9392,9837,10398,10791],0); -ELEMENTS[32396] = Fluid3D([5658,5786,5186,5751],0); -ELEMENTS[32397] = Fluid3D([18315,18460,18280,18436],0); -ELEMENTS[32398] = Fluid3D([18315,18460,18436,18443],0); -ELEMENTS[32399] = Fluid3D([18280,18315,18436,18244],0); -ELEMENTS[32400] = Fluid3D([18460,18280,18436,18547],0); -ELEMENTS[32401] = Fluid3D([18460,18280,18547,18507],0); -ELEMENTS[32402] = Fluid3D([18547,18460,18507,18594],0); -ELEMENTS[32403] = Fluid3D([18460,18507,18594,18564],0); -ELEMENTS[32404] = Fluid3D([18436,18460,18547,18545],0); -ELEMENTS[32405] = Fluid3D([8210,8799,8209,7621],0); -ELEMENTS[32406] = Fluid3D([14430,15049,15124,15217],0); -ELEMENTS[32407] = Fluid3D([15049,15124,15217,15655],0); -ELEMENTS[32408] = Fluid3D([15217,15049,15655,15906],0); -ELEMENTS[32409] = Fluid3D([15124,15217,15655,15652],0); -ELEMENTS[32410] = Fluid3D([14430,15049,15217,14657],0); -ELEMENTS[32411] = Fluid3D([15049,15124,15655,15488],0); -ELEMENTS[32412] = Fluid3D([11932,11997,11498,12918],0); -ELEMENTS[32413] = Fluid3D([4595,4063,4250,4410],0); -ELEMENTS[32414] = Fluid3D([5009,5621,5555,5508],0); -ELEMENTS[32415] = Fluid3D([13944,13310,13075,13402],0); -ELEMENTS[32416] = Fluid3D([13075,13944,13402,13645],0); -ELEMENTS[32417] = Fluid3D([13944,13402,13645,14122],0); -ELEMENTS[32418] = Fluid3D([13402,13645,14122,13758],0); -ELEMENTS[32419] = Fluid3D([13645,14122,13758,14375],0); -ELEMENTS[32420] = Fluid3D([13645,13944,14122,14599],0); -ELEMENTS[32421] = Fluid3D([13944,13310,13402,14032],0); -ELEMENTS[32422] = Fluid3D([13402,13944,14032,14122],0); -ELEMENTS[32423] = Fluid3D([14032,13402,14122,13798],0); -ELEMENTS[32424] = Fluid3D([14032,13402,13798,13525],0); -ELEMENTS[32425] = Fluid3D([14032,13402,13525,13738],0); -ELEMENTS[32426] = Fluid3D([14032,13402,13738,13310],0); -ELEMENTS[32427] = Fluid3D([13075,13944,13645,13872],0); -ELEMENTS[32428] = Fluid3D([13310,13075,13402,12444],0); -ELEMENTS[32429] = Fluid3D([13402,13075,13645,12555],0); -ELEMENTS[32430] = Fluid3D([9568,9088,9261,8645],0); -ELEMENTS[32431] = Fluid3D([3812,4169,3984,3844],0); -ELEMENTS[32432] = Fluid3D([14066,13392,13760,14529],0); -ELEMENTS[32433] = Fluid3D([9661,9908,10120,9089],0); -ELEMENTS[32434] = Fluid3D([16167,15900,15550,16194],0); -ELEMENTS[32435] = Fluid3D([3503,3413,3210,3159],0); -ELEMENTS[32436] = Fluid3D([13177,12986,12358,12382],0); -ELEMENTS[32437] = Fluid3D([5635,5518,5201,5611],0); -ELEMENTS[32438] = Fluid3D([7356,6893,6515,7318],0); -ELEMENTS[32439] = Fluid3D([7363,7129,6572,7396],0); -ELEMENTS[32440] = Fluid3D([9068,9781,9956,9189],0); -ELEMENTS[32441] = Fluid3D([9956,9068,9189,9186],0); -ELEMENTS[32442] = Fluid3D([9068,9189,9186,8479],0); -ELEMENTS[32443] = Fluid3D([9068,9189,8479,8566],0); -ELEMENTS[32444] = Fluid3D([9189,9186,8479,8859],0); -ELEMENTS[32445] = Fluid3D([9186,8479,8859,8373],0); -ELEMENTS[32446] = Fluid3D([9186,9068,8479,8656],0); -ELEMENTS[32447] = Fluid3D([9189,9186,8859,9572],0); -ELEMENTS[32448] = Fluid3D([8479,9186,8656,8373],0); -ELEMENTS[32449] = Fluid3D([9189,9956,9186,9572],0); -ELEMENTS[32450] = Fluid3D([9068,9781,9189,8566],0); -ELEMENTS[32451] = Fluid3D([8656,8479,8373,7918],0); -ELEMENTS[32452] = Fluid3D([8373,8656,7918,8294],0); -ELEMENTS[32453] = Fluid3D([8656,8479,7918,8511],0); -ELEMENTS[32454] = Fluid3D([9068,8479,8656,8511],0); -ELEMENTS[32455] = Fluid3D([8656,9068,8511,8959],0); -ELEMENTS[32456] = Fluid3D([8511,8656,8959,8071],0); -ELEMENTS[32457] = Fluid3D([8656,8959,8071,9035],0); -ELEMENTS[32458] = Fluid3D([8959,8511,8071,8683],0); -ELEMENTS[32459] = Fluid3D([9068,8511,8959,8685],0); -ELEMENTS[32460] = Fluid3D([9068,8511,8685,8552],0); -ELEMENTS[32461] = Fluid3D([8511,8959,8685,8683],0); -ELEMENTS[32462] = Fluid3D([9186,8859,9572,9584],0); -ELEMENTS[32463] = Fluid3D([9186,8656,8373,9488],0); -ELEMENTS[32464] = Fluid3D([9186,8656,9488,9068],0); -ELEMENTS[32465] = Fluid3D([8373,8656,8294,9488],0); -ELEMENTS[32466] = Fluid3D([7918,8656,8511,8071],0); -ELEMENTS[32467] = Fluid3D([7918,8656,8071,8294],0); -ELEMENTS[32468] = Fluid3D([8511,7918,8071,7779],0); -ELEMENTS[32469] = Fluid3D([7918,8071,7779,7236],0); -ELEMENTS[32470] = Fluid3D([8071,7779,7236,7572],0); -ELEMENTS[32471] = Fluid3D([8071,8511,7779,8683],0); -ELEMENTS[32472] = Fluid3D([7918,8071,7236,8294],0); -ELEMENTS[32473] = Fluid3D([8859,9186,8373,9274],0); -ELEMENTS[32474] = Fluid3D([8859,9186,9274,9584],0); -ELEMENTS[32475] = Fluid3D([9186,8373,9274,9488],0); -ELEMENTS[32476] = Fluid3D([9274,9186,9488,9935],0); -ELEMENTS[32477] = Fluid3D([9274,9186,9935,9584],0); -ELEMENTS[32478] = Fluid3D([9488,9274,9935,10474],0); -ELEMENTS[32479] = Fluid3D([8479,9189,8859,8593],0); -ELEMENTS[32480] = Fluid3D([9068,8479,8511,8458],0); -ELEMENTS[32481] = Fluid3D([8511,9068,8458,8552],0); -ELEMENTS[32482] = Fluid3D([9068,8479,8458,8566],0); -ELEMENTS[32483] = Fluid3D([8479,8373,7918,8029],0); -ELEMENTS[32484] = Fluid3D([9956,9068,9186,9488],0); -ELEMENTS[32485] = Fluid3D([8656,9068,8959,9488],0); -ELEMENTS[32486] = Fluid3D([8959,8656,9488,9035],0); -ELEMENTS[32487] = Fluid3D([8859,8479,8593,8029],0); -ELEMENTS[32488] = Fluid3D([8479,9189,8593,8566],0); -ELEMENTS[32489] = Fluid3D([8656,8071,8294,9035],0); -ELEMENTS[32490] = Fluid3D([18130,17930,18252,18024],0); -ELEMENTS[32491] = Fluid3D([18252,18130,18024,18287],0); -ELEMENTS[32492] = Fluid3D([18130,17930,18024,17671],0); -ELEMENTS[32493] = Fluid3D([17930,18252,18024,17995],0); -ELEMENTS[32494] = Fluid3D([4734,4500,5021,4266],0); -ELEMENTS[32495] = Fluid3D([10689,11283,10770,12012],0); -ELEMENTS[32496] = Fluid3D([14244,14607,14466,15034],0); -ELEMENTS[32497] = Fluid3D([15606,15935,16146,16045],0); -ELEMENTS[32498] = Fluid3D([10604,10600,11656,10634],0); -ELEMENTS[32499] = Fluid3D([4296,4568,4753,4097],0); -ELEMENTS[32500] = Fluid3D([8284,7484,7943,8322],0); -ELEMENTS[32501] = Fluid3D([5798,5978,5924,6661],0); -ELEMENTS[32502] = Fluid3D([14779,14733,15387,15131],0); -ELEMENTS[32503] = Fluid3D([9298,9317,8671,8545],0); -ELEMENTS[32504] = Fluid3D([9298,9317,8545,9114],0); -ELEMENTS[32505] = Fluid3D([8545,9298,9114,8509],0); -ELEMENTS[32506] = Fluid3D([8671,9298,8545,8189],0); -ELEMENTS[32507] = Fluid3D([9317,8545,9114,8998],0); -ELEMENTS[32508] = Fluid3D([9317,8545,8998,8462],0); -ELEMENTS[32509] = Fluid3D([9114,9317,8998,9682],0); -ELEMENTS[32510] = Fluid3D([9298,8545,8189,8509],0); -ELEMENTS[32511] = Fluid3D([9298,9317,9114,10010],0); -ELEMENTS[32512] = Fluid3D([13308,13109,13652,12673],0); -ELEMENTS[32513] = Fluid3D([16203,16622,16683,16475],0); -ELEMENTS[32514] = Fluid3D([10520,10001,11044,10116],0); -ELEMENTS[32515] = Fluid3D([6193,5908,6630,5852],0); -ELEMENTS[32516] = Fluid3D([11181,11721,10706,11162],0); -ELEMENTS[32517] = Fluid3D([17147,16804,17129,17250],0); -ELEMENTS[32518] = Fluid3D([16804,17129,17250,16981],0); -ELEMENTS[32519] = Fluid3D([17147,16804,17250,16745],0); -ELEMENTS[32520] = Fluid3D([17129,17147,17250,17496],0); -ELEMENTS[32521] = Fluid3D([17250,17129,17496,17357],0); -ELEMENTS[32522] = Fluid3D([17496,17250,17357,17632],0); -ELEMENTS[32523] = Fluid3D([17250,17357,17632,17508],0); -ELEMENTS[32524] = Fluid3D([17496,17250,17632,17490],0); -ELEMENTS[32525] = Fluid3D([17496,17250,17490,17147],0); -ELEMENTS[32526] = Fluid3D([17250,17490,17147,17374],0); -ELEMENTS[32527] = Fluid3D([17250,17632,17490,17389],0); -ELEMENTS[32528] = Fluid3D([17250,17632,17389,17508],0); -ELEMENTS[32529] = Fluid3D([17490,17250,17389,17374],0); -ELEMENTS[32530] = Fluid3D([17389,17490,17374,17883],0); -ELEMENTS[32531] = Fluid3D([17129,17147,17496,17198],0); -ELEMENTS[32532] = Fluid3D([15507,15537,15316,14462],0); -ELEMENTS[32533] = Fluid3D([14112,13785,13707,13040],0); -ELEMENTS[32534] = Fluid3D([2865,2665,2666,2474],0); -ELEMENTS[32535] = Fluid3D([3596,3252,3313,3546],0); -ELEMENTS[32536] = Fluid3D([16918,17311,17219,16786],0); -ELEMENTS[32537] = Fluid3D([7604,8252,8270,7852],0); -ELEMENTS[32538] = Fluid3D([8021,7953,7217,7554],0); -ELEMENTS[32539] = Fluid3D([11898,11299,10990,10700],0); -ELEMENTS[32540] = Fluid3D([17409,17344,16985,17151],0); -ELEMENTS[32541] = Fluid3D([16985,17409,17151,17138],0); -ELEMENTS[32542] = Fluid3D([13384,13250,13888,14117],0); -ELEMENTS[32543] = Fluid3D([3190,3644,3353,3273],0); -ELEMENTS[32544] = Fluid3D([8120,8019,7628,8831],0); -ELEMENTS[32545] = Fluid3D([8120,8019,8831,8766],0); -ELEMENTS[32546] = Fluid3D([8831,8120,8766,9046],0); -ELEMENTS[32547] = Fluid3D([10671,11079,10874,11654],0); -ELEMENTS[32548] = Fluid3D([10874,10671,11654,10851],0); -ELEMENTS[32549] = Fluid3D([10671,11079,11654,11498],0); -ELEMENTS[32550] = Fluid3D([11079,10874,11654,11601],0); -ELEMENTS[32551] = Fluid3D([11654,11079,11601,11923],0); -ELEMENTS[32552] = Fluid3D([11079,10874,11601,10699],0); -ELEMENTS[32553] = Fluid3D([10874,11654,11601,11948],0); -ELEMENTS[32554] = Fluid3D([12956,13453,12646,13613],0); -ELEMENTS[32555] = Fluid3D([12554,12797,12588,11790],0); -ELEMENTS[32556] = Fluid3D([6140,6196,5626,6116],0); -ELEMENTS[32557] = Fluid3D([5626,6140,6116,5479],0); -ELEMENTS[32558] = Fluid3D([8926,8271,8743,9697],0); -ELEMENTS[32559] = Fluid3D([16225,16755,16482,16581],0); -ELEMENTS[32560] = Fluid3D([15196,14854,15407,14742],0); -ELEMENTS[32561] = Fluid3D([14854,15407,14742,15459],0); -ELEMENTS[32562] = Fluid3D([15407,14742,15459,14939],0); -ELEMENTS[32563] = Fluid3D([15407,14742,14939,15196],0); -ELEMENTS[32564] = Fluid3D([15459,15407,14939,15473],0); -ELEMENTS[32565] = Fluid3D([15407,14939,15473,15247],0); -ELEMENTS[32566] = Fluid3D([12209,12546,12719,12075],0); -ELEMENTS[32567] = Fluid3D([12546,12719,12075,13069],0); -ELEMENTS[32568] = Fluid3D([12719,12075,13069,12761],0); -ELEMENTS[32569] = Fluid3D([12075,13069,12761,12484],0); -ELEMENTS[32570] = Fluid3D([12719,12075,12761,11721],0); -ELEMENTS[32571] = Fluid3D([13069,12719,12761,13698],0); -ELEMENTS[32572] = Fluid3D([12761,12075,12484,12344],0); -ELEMENTS[32573] = Fluid3D([12761,12075,12344,11609],0); -ELEMENTS[32574] = Fluid3D([12075,13069,12484,12546],0); -ELEMENTS[32575] = Fluid3D([12546,12719,13069,13473],0); -ELEMENTS[32576] = Fluid3D([12719,13069,13473,13698],0); -ELEMENTS[32577] = Fluid3D([10781,11512,10708,10255],0); -ELEMENTS[32578] = Fluid3D([5805,5696,6253,5295],0); -ELEMENTS[32579] = Fluid3D([9583,9771,9506,10862],0); -ELEMENTS[32580] = Fluid3D([5418,5277,4740,5251],0); -ELEMENTS[32581] = Fluid3D([16069,15815,15517,16437],0); -ELEMENTS[32582] = Fluid3D([9779,10635,9828,9461],0); -ELEMENTS[32583] = Fluid3D([7280,7843,7095,7722],0); -ELEMENTS[32584] = Fluid3D([9169,8789,8927,7826],0); -ELEMENTS[32585] = Fluid3D([14970,14849,14262,14649],0); -ELEMENTS[32586] = Fluid3D([17527,17310,17683,17628],0); -ELEMENTS[32587] = Fluid3D([3246,3534,3299,3769],0); -ELEMENTS[32588] = Fluid3D([15147,15576,14897,14974],0); -ELEMENTS[32589] = Fluid3D([4350,4806,4361,4564],0); -ELEMENTS[32590] = Fluid3D([9329,8800,9390,9748],0); -ELEMENTS[32591] = Fluid3D([13007,12777,13592,13718],0); -ELEMENTS[32592] = Fluid3D([13794,14530,14495,14178],0); -ELEMENTS[32593] = Fluid3D([17590,17874,17889,17972],0); -ELEMENTS[32594] = Fluid3D([3550,3540,3530,4084],0); -ELEMENTS[32595] = Fluid3D([4639,5049,4596,4620],0); -ELEMENTS[32596] = Fluid3D([12649,13419,12665,12960],0); -ELEMENTS[32597] = Fluid3D([13419,12665,12960,13309],0); -ELEMENTS[32598] = Fluid3D([17901,18014,17798,18009],0); -ELEMENTS[32599] = Fluid3D([12123,11860,11395,11441],0); -ELEMENTS[32600] = Fluid3D([11777,11593,10964,11215],0); -ELEMENTS[32601] = Fluid3D([17223,16784,16885,17112],0); -ELEMENTS[32602] = Fluid3D([15099,15251,14569,15045],0); -ELEMENTS[32603] = Fluid3D([11381,12204,11580,11726],0); -ELEMENTS[32604] = Fluid3D([4362,4319,4536,4879],0); -ELEMENTS[32605] = Fluid3D([3794,3600,4052,3839],0); -ELEMENTS[32606] = Fluid3D([3600,4052,3839,3814],0); -ELEMENTS[32607] = Fluid3D([4052,3839,3814,4261],0); -ELEMENTS[32608] = Fluid3D([4052,3794,3839,4467],0); -ELEMENTS[32609] = Fluid3D([3839,3814,4261,4389],0); -ELEMENTS[32610] = Fluid3D([3794,3600,3839,3419],0); -ELEMENTS[32611] = Fluid3D([3600,4052,3814,3810],0); -ELEMENTS[32612] = Fluid3D([3814,4052,4261,4258],0); -ELEMENTS[32613] = Fluid3D([4261,3814,4258,4230],0); -ELEMENTS[32614] = Fluid3D([4258,4261,4230,4738],0); -ELEMENTS[32615] = Fluid3D([3839,3600,3814,3450],0); -ELEMENTS[32616] = Fluid3D([3600,3814,3450,3402],0); -ELEMENTS[32617] = Fluid3D([3839,3600,3450,3261],0); -ELEMENTS[32618] = Fluid3D([3450,3600,3402,3116],0); -ELEMENTS[32619] = Fluid3D([3814,3839,3450,3746],0); -ELEMENTS[32620] = Fluid3D([4052,3839,4261,4433],0); -ELEMENTS[32621] = Fluid3D([4261,4052,4433,4258],0); -ELEMENTS[32622] = Fluid3D([4433,4261,4258,4738],0); -ELEMENTS[32623] = Fluid3D([4433,4261,4738,4467],0); -ELEMENTS[32624] = Fluid3D([3839,4261,4433,4467],0); -ELEMENTS[32625] = Fluid3D([4052,3839,4433,4467],0); -ELEMENTS[32626] = Fluid3D([3600,3814,3402,3810],0); -ELEMENTS[32627] = Fluid3D([3814,3450,3402,3490],0); -ELEMENTS[32628] = Fluid3D([16729,16428,16213,16438],0); -ELEMENTS[32629] = Fluid3D([11680,12240,12107,11298],0); -ELEMENTS[32630] = Fluid3D([11680,12240,11298,11829],0); -ELEMENTS[32631] = Fluid3D([12107,11680,11298,10814],0); -ELEMENTS[32632] = Fluid3D([12240,12107,11298,12445],0); -ELEMENTS[32633] = Fluid3D([6793,7007,6204,6729],0); -ELEMENTS[32634] = Fluid3D([12085,11956,12245,12943],0); -ELEMENTS[32635] = Fluid3D([12245,12085,12943,12977],0); -ELEMENTS[32636] = Fluid3D([12085,11956,12943,12633],0); -ELEMENTS[32637] = Fluid3D([15145,15135,15579,15841],0); -ELEMENTS[32638] = Fluid3D([8359,8121,8574,8925],0); -ELEMENTS[32639] = Fluid3D([8574,8359,8925,9216],0); -ELEMENTS[32640] = Fluid3D([8121,8574,8925,8916],0); -ELEMENTS[32641] = Fluid3D([8359,8121,8925,8375],0); -ELEMENTS[32642] = Fluid3D([8412,8207,8006,7610],0); -ELEMENTS[32643] = Fluid3D([8207,8006,7610,8052],0); -ELEMENTS[32644] = Fluid3D([6314,6397,6005,5535],0); -ELEMENTS[32645] = Fluid3D([12660,12469,12738,11911],0); -ELEMENTS[32646] = Fluid3D([12469,12738,11911,11726],0); -ELEMENTS[32647] = Fluid3D([12738,12660,11911,12438],0); -ELEMENTS[32648] = Fluid3D([12660,11911,12438,11656],0); -ELEMENTS[32649] = Fluid3D([12660,12469,11911,11656],0); -ELEMENTS[32650] = Fluid3D([12469,11911,11656,11631],0); -ELEMENTS[32651] = Fluid3D([11911,11656,11631,10604],0); -ELEMENTS[32652] = Fluid3D([12469,11911,11631,11726],0); -ELEMENTS[32653] = Fluid3D([11911,11631,11726,10604],0); -ELEMENTS[32654] = Fluid3D([5525,5654,5605,5934],0); -ELEMENTS[32655] = Fluid3D([5605,5525,5934,5261],0); -ELEMENTS[32656] = Fluid3D([5525,5654,5934,5845],0); -ELEMENTS[32657] = Fluid3D([5654,5605,5934,6168],0); -ELEMENTS[32658] = Fluid3D([5934,5654,6168,6462],0); -ELEMENTS[32659] = Fluid3D([11229,11832,11604,12711],0); -ELEMENTS[32660] = Fluid3D([16616,16228,16263,16075],0); -ELEMENTS[32661] = Fluid3D([13919,13791,14661,13990],0); -ELEMENTS[32662] = Fluid3D([13919,13791,13990,12869],0); -ELEMENTS[32663] = Fluid3D([13791,14661,13990,14665],0); -ELEMENTS[32664] = Fluid3D([14661,13919,13990,14214],0); -ELEMENTS[32665] = Fluid3D([16219,16780,16396,16233],0); -ELEMENTS[32666] = Fluid3D([16396,16219,16233,15572],0); -ELEMENTS[32667] = Fluid3D([16219,16780,16233,16620],0); -ELEMENTS[32668] = Fluid3D([16780,16396,16233,16923],0); -ELEMENTS[32669] = Fluid3D([16077,16410,16275,15655],0); -ELEMENTS[32670] = Fluid3D([12289,11885,11148,11923],0); -ELEMENTS[32671] = Fluid3D([5831,6197,6438,6388],0); -ELEMENTS[32672] = Fluid3D([5602,5769,6251,5615],0); -ELEMENTS[32673] = Fluid3D([17141,17275,17154,17626],0); -ELEMENTS[32674] = Fluid3D([2143,2157,1977,2258],0); -ELEMENTS[32675] = Fluid3D([10852,10115,9825,10400],0); -ELEMENTS[32676] = Fluid3D([15002,14486,14887,15318],0); -ELEMENTS[32677] = Fluid3D([15289,15053,15713,15564],0); -ELEMENTS[32678] = Fluid3D([15713,15289,15564,15742],0); -ELEMENTS[32679] = Fluid3D([15289,15053,15564,15069],0); -ELEMENTS[32680] = Fluid3D([8589,8164,8850,7655],0); -ELEMENTS[32681] = Fluid3D([10147,9542,10349,10099],0); -ELEMENTS[32682] = Fluid3D([10147,9542,10099,9335],0); -ELEMENTS[32683] = Fluid3D([9542,10099,9335,9313],0); -ELEMENTS[32684] = Fluid3D([10099,10147,9335,10241],0); -ELEMENTS[32685] = Fluid3D([9335,10099,10241,9858],0); -ELEMENTS[32686] = Fluid3D([13189,12909,13845,13404],0); -ELEMENTS[32687] = Fluid3D([5474,5552,5944,5297],0); -ELEMENTS[32688] = Fluid3D([8466,8498,8871,9145],0); -ELEMENTS[32689] = Fluid3D([12985,13445,13812,13410],0); -ELEMENTS[32690] = Fluid3D([8122,8271,8926,8452],0); -ELEMENTS[32691] = Fluid3D([8122,8271,8452,7584],0); -ELEMENTS[32692] = Fluid3D([7490,8189,7456,7542],0); -ELEMENTS[32693] = Fluid3D([17058,17216,16757,17012],0); -ELEMENTS[32694] = Fluid3D([4302,4968,4603,5005],0); -ELEMENTS[32695] = Fluid3D([9770,10908,10269,11256],0); -ELEMENTS[32696] = Fluid3D([10262,10381,10153,9603],0); -ELEMENTS[32697] = Fluid3D([10262,10381,9603,10187],0); -ELEMENTS[32698] = Fluid3D([10381,10153,9603,10313],0); -ELEMENTS[32699] = Fluid3D([10381,9603,10187,9892],0); -ELEMENTS[32700] = Fluid3D([10381,9603,9892,9674],0); -ELEMENTS[32701] = Fluid3D([10381,9603,9674,10313],0); -ELEMENTS[32702] = Fluid3D([9603,9892,9674,9011],0); -ELEMENTS[32703] = Fluid3D([9674,9603,9011,10313],0); -ELEMENTS[32704] = Fluid3D([9892,10381,9674,10561],0); -ELEMENTS[32705] = Fluid3D([10381,9674,10561,10313],0); -ELEMENTS[32706] = Fluid3D([9892,10381,10561,11203],0); -ELEMENTS[32707] = Fluid3D([9674,9892,10561,9851],0); -ELEMENTS[32708] = Fluid3D([10889,10887,10558,11966],0); -ELEMENTS[32709] = Fluid3D([7732,8633,8070,7716],0); -ELEMENTS[32710] = Fluid3D([6751,6269,6341,5883],0); -ELEMENTS[32711] = Fluid3D([14573,14040,14643,15045],0); -ELEMENTS[32712] = Fluid3D([14643,14573,15045,15435],0); -ELEMENTS[32713] = Fluid3D([17028,16666,16819,17050],0); -ELEMENTS[32714] = Fluid3D([17028,16666,17050,17219],0); -ELEMENTS[32715] = Fluid3D([16666,16819,17050,16700],0); -ELEMENTS[32716] = Fluid3D([16666,16819,16700,16057],0); -ELEMENTS[32717] = Fluid3D([17050,16666,16700,16660],0); -ELEMENTS[32718] = Fluid3D([16819,17028,17050,17149],0); -ELEMENTS[32719] = Fluid3D([17050,16819,17149,17202],0); -ELEMENTS[32720] = Fluid3D([17149,17050,17202,17498],0); -ELEMENTS[32721] = Fluid3D([17202,17149,17498,17382],0); -ELEMENTS[32722] = Fluid3D([17149,17498,17382,17375],0); -ELEMENTS[32723] = Fluid3D([17149,17498,17375,17050],0); -ELEMENTS[32724] = Fluid3D([17202,17149,17382,17072],0); -ELEMENTS[32725] = Fluid3D([17382,17149,17375,17301],0); -ELEMENTS[32726] = Fluid3D([17382,17149,17301,16948],0); -ELEMENTS[32727] = Fluid3D([17149,17375,17301,17028],0); -ELEMENTS[32728] = Fluid3D([17149,17375,17028,17050],0); -ELEMENTS[32729] = Fluid3D([16819,17028,17149,16806],0); -ELEMENTS[32730] = Fluid3D([16819,17050,16700,17202],0); -ELEMENTS[32731] = Fluid3D([3437,3834,3675,4101],0); -ELEMENTS[32732] = Fluid3D([3834,3675,4101,4286],0); -ELEMENTS[32733] = Fluid3D([11145,10494,10862,10156],0); -ELEMENTS[32734] = Fluid3D([10862,11145,10156,10874],0); -ELEMENTS[32735] = Fluid3D([11145,10494,10156,10851],0); -ELEMENTS[32736] = Fluid3D([10494,10862,10156,9506],0); -ELEMENTS[32737] = Fluid3D([10156,10494,9506,9832],0); -ELEMENTS[32738] = Fluid3D([9506,10156,9832,9944],0); -ELEMENTS[32739] = Fluid3D([9506,10156,9944,9126],0); -ELEMENTS[32740] = Fluid3D([9506,10156,9126,9583],0); -ELEMENTS[32741] = Fluid3D([9506,10156,9583,10862],0); -ELEMENTS[32742] = Fluid3D([10156,9944,9126,9961],0); -ELEMENTS[32743] = Fluid3D([10156,11145,10851,10874],0); -ELEMENTS[32744] = Fluid3D([6522,7037,6102,6808],0); -ELEMENTS[32745] = Fluid3D([6337,6985,6923,7316],0); -ELEMENTS[32746] = Fluid3D([17157,17116,16727,17001],0); -ELEMENTS[32747] = Fluid3D([17157,17116,17001,17448],0); -ELEMENTS[32748] = Fluid3D([16727,17157,17001,17020],0); -ELEMENTS[32749] = Fluid3D([17157,17001,17020,17344],0); -ELEMENTS[32750] = Fluid3D([17001,17020,17344,16985],0); -ELEMENTS[32751] = Fluid3D([17344,17001,16985,17151],0); -ELEMENTS[32752] = Fluid3D([17001,17020,16985,16505],0); -ELEMENTS[32753] = Fluid3D([17116,16727,17001,16914],0); -ELEMENTS[32754] = Fluid3D([15063,14460,14513,14858],0); -ELEMENTS[32755] = Fluid3D([13331,13384,13556,14198],0); -ELEMENTS[32756] = Fluid3D([5155,5348,5798,5602],0); -ELEMENTS[32757] = Fluid3D([4741,4251,4746,4579],0); -ELEMENTS[32758] = Fluid3D([4746,4741,4579,5068],0); -ELEMENTS[32759] = Fluid3D([4741,4579,5068,4478],0); -ELEMENTS[32760] = Fluid3D([5068,4741,4478,5282],0); -ELEMENTS[32761] = Fluid3D([5068,4741,5282,5603],0); -ELEMENTS[32762] = Fluid3D([4741,4579,4478,4251],0); -ELEMENTS[32763] = Fluid3D([4251,4746,4579,4307],0); -ELEMENTS[32764] = Fluid3D([8050,8848,8840,8795],0); -ELEMENTS[32765] = Fluid3D([14379,14594,14798,15380],0); -ELEMENTS[32766] = Fluid3D([13860,14109,13222,14201],0); -ELEMENTS[32767] = Fluid3D([5351,5923,5396,5628],0); -ELEMENTS[32768] = Fluid3D([7500,7761,8211,8249],0); -ELEMENTS[32769] = Fluid3D([7500,7761,8249,7461],0); -ELEMENTS[32770] = Fluid3D([7761,8211,8249,8647],0); -ELEMENTS[32771] = Fluid3D([8211,7500,8249,8676],0); -ELEMENTS[32772] = Fluid3D([8249,8211,8676,8647],0); -ELEMENTS[32773] = Fluid3D([16854,16670,16362,16486],0); -ELEMENTS[32774] = Fluid3D([6538,6807,6790,7584],0); -ELEMENTS[32775] = Fluid3D([15522,15155,15826,15483],0); -ELEMENTS[32776] = Fluid3D([15826,15522,15483,16204],0); -ELEMENTS[32777] = Fluid3D([15522,15155,15483,14645],0); -ELEMENTS[32778] = Fluid3D([15155,15826,15483,15384],0); -ELEMENTS[32779] = Fluid3D([10316,11021,10437,10222],0); -ELEMENTS[32780] = Fluid3D([11021,10437,10222,10619],0); -ELEMENTS[32781] = Fluid3D([10316,11021,10222,10659],0); -ELEMENTS[32782] = Fluid3D([5875,5436,6047,5806],0); -ELEMENTS[32783] = Fluid3D([8029,7182,7754,7918],0); -ELEMENTS[32784] = Fluid3D([15144,15240,15726,15268],0); -ELEMENTS[32785] = Fluid3D([11271,10474,10432,10479],0); -ELEMENTS[32786] = Fluid3D([15827,15801,15245,15921],0); -ELEMENTS[32787] = Fluid3D([9953,9655,9387,9000],0); -ELEMENTS[32788] = Fluid3D([7849,7185,7889,7410],0); -ELEMENTS[32789] = Fluid3D([17802,17805,17951,18026],0); -ELEMENTS[32790] = Fluid3D([17805,17951,18026,17965],0); -ELEMENTS[32791] = Fluid3D([17805,17951,17965,17799],0); -ELEMENTS[32792] = Fluid3D([17965,17805,17799,17789],0); -ELEMENTS[32793] = Fluid3D([18026,17805,17965,17947],0); -ELEMENTS[32794] = Fluid3D([17805,17965,17947,17855],0); -ELEMENTS[32795] = Fluid3D([17951,17965,17799,18090],0); -ELEMENTS[32796] = Fluid3D([17965,17799,18090,17789],0); -ELEMENTS[32797] = Fluid3D([17799,17951,18090,17905],0); -ELEMENTS[32798] = Fluid3D([18090,17799,17905,17921],0); -ELEMENTS[32799] = Fluid3D([18090,17799,17921,17789],0); -ELEMENTS[32800] = Fluid3D([17799,17905,17921,17708],0); -ELEMENTS[32801] = Fluid3D([17905,17921,17708,18043],0); -ELEMENTS[32802] = Fluid3D([17921,17799,17708,17589],0); -ELEMENTS[32803] = Fluid3D([17708,17921,17589,17647],0); -ELEMENTS[32804] = Fluid3D([17921,17799,17589,17789],0); -ELEMENTS[32805] = Fluid3D([17905,18090,17921,18203],0); -ELEMENTS[32806] = Fluid3D([17802,17805,18026,17796],0); -ELEMENTS[32807] = Fluid3D([17951,17802,18026,18029],0); -ELEMENTS[32808] = Fluid3D([17802,18026,18029,18309],0); -ELEMENTS[32809] = Fluid3D([18026,18029,18309,18198],0); -ELEMENTS[32810] = Fluid3D([18309,18026,18198,18279],0); -ELEMENTS[32811] = Fluid3D([18309,18026,18279,18196],0); -ELEMENTS[32812] = Fluid3D([18309,18026,18196,17982],0); -ELEMENTS[32813] = Fluid3D([18026,18279,18196,17947],0); -ELEMENTS[32814] = Fluid3D([18026,18198,18279,17965],0); -ELEMENTS[32815] = Fluid3D([18279,18309,18196,18419],0); -ELEMENTS[32816] = Fluid3D([18198,18309,18279,18476],0); -ELEMENTS[32817] = Fluid3D([18309,18196,18419,18254],0); -ELEMENTS[32818] = Fluid3D([18419,18309,18254,18490],0); -ELEMENTS[32819] = Fluid3D([18254,18419,18490,18372],0); -ELEMENTS[32820] = Fluid3D([18419,18490,18372,18482],0); -ELEMENTS[32821] = Fluid3D([18196,18419,18254,18372],0); -ELEMENTS[32822] = Fluid3D([18419,18490,18482,18563],0); -ELEMENTS[32823] = Fluid3D([18279,18309,18419,18476],0); -ELEMENTS[32824] = Fluid3D([18026,18196,17982,17796],0); -ELEMENTS[32825] = Fluid3D([18196,17982,17796,17959],0); -ELEMENTS[32826] = Fluid3D([17982,17796,17959,17652],0); -ELEMENTS[32827] = Fluid3D([18196,17982,17959,18023],0); -ELEMENTS[32828] = Fluid3D([18026,18029,18198,17951],0); -ELEMENTS[32829] = Fluid3D([18198,18026,17951,17965],0); -ELEMENTS[32830] = Fluid3D([17982,17959,18023,17652],0); -ELEMENTS[32831] = Fluid3D([18196,18279,18419,18372],0); -ELEMENTS[32832] = Fluid3D([18309,18196,18254,17982],0); -ELEMENTS[32833] = Fluid3D([18090,17921,18203,18156],0); -ELEMENTS[32834] = Fluid3D([18203,18090,18156,18356],0); -ELEMENTS[32835] = Fluid3D([18090,17921,18156,17789],0); -ELEMENTS[32836] = Fluid3D([17799,17951,17905,17631],0); -ELEMENTS[32837] = Fluid3D([17951,17802,18029,17786],0); -ELEMENTS[32838] = Fluid3D([3447,3740,3880,3712],0); -ELEMENTS[32839] = Fluid3D([10498,9649,10569,10107],0); -ELEMENTS[32840] = Fluid3D([10498,9649,10107,9474],0); -ELEMENTS[32841] = Fluid3D([10569,10498,10107,10599],0); -ELEMENTS[32842] = Fluid3D([10107,10569,10599,10178],0); -ELEMENTS[32843] = Fluid3D([10599,10107,10178,9474],0); -ELEMENTS[32844] = Fluid3D([10599,10107,9474,10503],0); -ELEMENTS[32845] = Fluid3D([10107,10178,9474,9649],0); -ELEMENTS[32846] = Fluid3D([10599,10107,10503,10498],0); -ELEMENTS[32847] = Fluid3D([10107,10569,10178,9649],0); -ELEMENTS[32848] = Fluid3D([14014,13592,13610,14445],0); -ELEMENTS[32849] = Fluid3D([12972,12945,12729,12241],0); -ELEMENTS[32850] = Fluid3D([11003,12024,11394,11812],0); -ELEMENTS[32851] = Fluid3D([3926,4391,3955,4237],0); -ELEMENTS[32852] = Fluid3D([16337,16432,15897,16317],0); -ELEMENTS[32853] = Fluid3D([16432,15897,16317,16287],0); -ELEMENTS[32854] = Fluid3D([15979,16254,16543,16536],0); -ELEMENTS[32855] = Fluid3D([12077,11120,12059,11914],0); -ELEMENTS[32856] = Fluid3D([15099,15055,15254,14322],0); -ELEMENTS[32857] = Fluid3D([3116,3017,2783,2739],0); -ELEMENTS[32858] = Fluid3D([4914,5295,5369,5537],0); -ELEMENTS[32859] = Fluid3D([16078,16574,16149,16024],0); -ELEMENTS[32860] = Fluid3D([10920,10179,9865,10737],0); -ELEMENTS[32861] = Fluid3D([5450,5892,5947,5498],0); -ELEMENTS[32862] = Fluid3D([18044,17752,17875,18081],0); -ELEMENTS[32863] = Fluid3D([7805,8276,8375,7381],0); -ELEMENTS[32864] = Fluid3D([11369,12194,11485,12463],0); -ELEMENTS[32865] = Fluid3D([3671,3639,3158,3480],0); -ELEMENTS[32866] = Fluid3D([3158,3671,3480,3214],0); -ELEMENTS[32867] = Fluid3D([13628,13117,13541,12521],0); -ELEMENTS[32868] = Fluid3D([13988,14111,14648,14068],0); -ELEMENTS[32869] = Fluid3D([10391,11072,11058,10426],0); -ELEMENTS[32870] = Fluid3D([4190,4126,4485,3752],0); -ELEMENTS[32871] = Fluid3D([13318,13479,12758,13418],0); -ELEMENTS[32872] = Fluid3D([13479,12758,13418,12642],0); -ELEMENTS[32873] = Fluid3D([12758,13418,12642,12493],0); -ELEMENTS[32874] = Fluid3D([12758,13418,12493,13214],0); -ELEMENTS[32875] = Fluid3D([12642,12758,12493,11896],0); -ELEMENTS[32876] = Fluid3D([12758,12493,11896,12023],0); -ELEMENTS[32877] = Fluid3D([12642,12758,11896,12669],0); -ELEMENTS[32878] = Fluid3D([12493,12758,13214,12913],0); -ELEMENTS[32879] = Fluid3D([10260,10377,9491,10215],0); -ELEMENTS[32880] = Fluid3D([13720,13349,12977,14103],0); -ELEMENTS[32881] = Fluid3D([17408,17594,17631,17786],0); -ELEMENTS[32882] = Fluid3D([13585,13337,12689,12876],0); -ELEMENTS[32883] = Fluid3D([12619,13323,12589,12560],0); -ELEMENTS[32884] = Fluid3D([8584,8202,7967,8822],0); -ELEMENTS[32885] = Fluid3D([5301,5535,5685,4930],0); -ELEMENTS[32886] = Fluid3D([9821,9704,9945,10638],0); -ELEMENTS[32887] = Fluid3D([9821,9704,10638,10043],0); -ELEMENTS[32888] = Fluid3D([9945,9821,10638,10552],0); -ELEMENTS[32889] = Fluid3D([9704,9945,10638,10142],0); -ELEMENTS[32890] = Fluid3D([18535,18411,18520,18549],0); -ELEMENTS[32891] = Fluid3D([18411,18520,18549,18510],0); -ELEMENTS[32892] = Fluid3D([18520,18535,18549,18638],0); -ELEMENTS[32893] = Fluid3D([18535,18411,18549,18450],0); -ELEMENTS[32894] = Fluid3D([4718,4466,4295,4371],0); -ELEMENTS[32895] = Fluid3D([4295,4718,4371,4797],0); -ELEMENTS[32896] = Fluid3D([4718,4371,4797,4600],0); -ELEMENTS[32897] = Fluid3D([14214,14233,14350,15060],0); -ELEMENTS[32898] = Fluid3D([14981,14528,15156,15396],0); -ELEMENTS[32899] = Fluid3D([16591,16883,16369,16947],0); -ELEMENTS[32900] = Fluid3D([16883,16369,16947,16977],0); -ELEMENTS[32901] = Fluid3D([16591,16883,16947,17160],0); -ELEMENTS[32902] = Fluid3D([9811,9894,9223,9057],0); -ELEMENTS[32903] = Fluid3D([12656,12675,12141,11387],0); -ELEMENTS[32904] = Fluid3D([6170,6190,5811,6713],0); -ELEMENTS[32905] = Fluid3D([13153,12334,13261,12641],0); -ELEMENTS[32906] = Fluid3D([11523,11728,11730,12647],0); -ELEMENTS[32907] = Fluid3D([13631,13113,12711,13528],0); -ELEMENTS[32908] = Fluid3D([9456,9045,8338,8688],0); -ELEMENTS[32909] = Fluid3D([12876,12174,12051,12474],0); -ELEMENTS[32910] = Fluid3D([4304,4548,4592,4084],0); -ELEMENTS[32911] = Fluid3D([16323,16590,16449,15849],0); -ELEMENTS[32912] = Fluid3D([10149,10007,10868,10558],0); -ELEMENTS[32913] = Fluid3D([10887,11630,11769,11966],0); -ELEMENTS[32914] = Fluid3D([16325,16644,16800,16516],0); -ELEMENTS[32915] = Fluid3D([7540,6739,7407,7170],0); -ELEMENTS[32916] = Fluid3D([9644,8968,8772,8666],0); -ELEMENTS[32917] = Fluid3D([6050,5748,6167,6541],0); -ELEMENTS[32918] = Fluid3D([15434,15680,15794,15213],0); -ELEMENTS[32919] = Fluid3D([5783,5929,5477,6362],0); -ELEMENTS[32920] = Fluid3D([3540,3537,3188,3385],0); -ELEMENTS[32921] = Fluid3D([13737,13995,13842,14863],0); -ELEMENTS[32922] = Fluid3D([17091,16909,16624,17108],0); -ELEMENTS[32923] = Fluid3D([14396,13745,14453,14735],0); -ELEMENTS[32924] = Fluid3D([3391,3941,3741,3622],0); -ELEMENTS[32925] = Fluid3D([15965,16498,16266,16439],0); -ELEMENTS[32926] = Fluid3D([10173,9652,9780,10825],0); -ELEMENTS[32927] = Fluid3D([3618,3655,3401,3367],0); -ELEMENTS[32928] = Fluid3D([14812,14615,15020,14491],0); -ELEMENTS[32929] = Fluid3D([8962,8112,7895,8192],0); -ELEMENTS[32930] = Fluid3D([5923,6446,6458,5855],0); -ELEMENTS[32931] = Fluid3D([5417,5789,5489,6193],0); -ELEMENTS[32932] = Fluid3D([12809,12014,12016,12714],0); -ELEMENTS[32933] = Fluid3D([6806,6624,7337,7310],0); -ELEMENTS[32934] = Fluid3D([13574,14045,13067,12970],0); -ELEMENTS[32935] = Fluid3D([10384,9359,9886,9924],0); -ELEMENTS[32936] = Fluid3D([10384,9359,9924,9664],0); -ELEMENTS[32937] = Fluid3D([9359,9886,9924,9175],0); -ELEMENTS[32938] = Fluid3D([9886,10384,9924,10746],0); -ELEMENTS[32939] = Fluid3D([5418,5761,5251,5022],0); -ELEMENTS[32940] = Fluid3D([15015,15712,15306,15617],0); -ELEMENTS[32941] = Fluid3D([11582,11445,12278,12734],0); -ELEMENTS[32942] = Fluid3D([7450,8274,7818,7872],0); -ELEMENTS[32943] = Fluid3D([7450,8274,7872,8116],0); -ELEMENTS[32944] = Fluid3D([8274,7818,7872,8549],0); -ELEMENTS[32945] = Fluid3D([7872,8274,8549,8465],0); -ELEMENTS[32946] = Fluid3D([8549,7872,8465,7934],0); -ELEMENTS[32947] = Fluid3D([7872,8465,7934,7728],0); -ELEMENTS[32948] = Fluid3D([7872,8465,7728,8116],0); -ELEMENTS[32949] = Fluid3D([8274,7818,8549,8770],0); -ELEMENTS[32950] = Fluid3D([8549,8274,8770,9567],0); -ELEMENTS[32951] = Fluid3D([8274,8549,8465,8948],0); -ELEMENTS[32952] = Fluid3D([8274,8549,8948,9567],0); -ELEMENTS[32953] = Fluid3D([8549,8465,8948,9348],0); -ELEMENTS[32954] = Fluid3D([7818,7450,7872,7225],0); -ELEMENTS[32955] = Fluid3D([7872,7818,7225,7934],0); -ELEMENTS[32956] = Fluid3D([7225,7872,7934,7728],0); -ELEMENTS[32957] = Fluid3D([16572,16685,16235,16741],0); -ELEMENTS[32958] = Fluid3D([16572,16685,16741,17166],0); -ELEMENTS[32959] = Fluid3D([16235,16572,16741,16311],0); -ELEMENTS[32960] = Fluid3D([16572,16741,16311,17036],0); -ELEMENTS[32961] = Fluid3D([16572,16741,17036,17166],0); -ELEMENTS[32962] = Fluid3D([16235,16572,16311,15876],0); -ELEMENTS[32963] = Fluid3D([16859,16415,16810,16787],0); -ELEMENTS[32964] = Fluid3D([12940,12551,12849,12016],0); -ELEMENTS[32965] = Fluid3D([10457,10143,10372,11216],0); -ELEMENTS[32966] = Fluid3D([3432,3339,3062,3234],0); -ELEMENTS[32967] = Fluid3D([11839,11724,11904,10780],0); -ELEMENTS[32968] = Fluid3D([12092,12428,11509,11838],0); -ELEMENTS[32969] = Fluid3D([9390,10015,10337,9327],0); -ELEMENTS[32970] = Fluid3D([12985,13812,13311,13410],0); -ELEMENTS[32971] = Fluid3D([8497,8996,8187,7955],0); -ELEMENTS[32972] = Fluid3D([5205,4964,5475,5466],0); -ELEMENTS[32973] = Fluid3D([4964,5475,5466,5106],0); -ELEMENTS[32974] = Fluid3D([17804,17451,17592,17475],0); -ELEMENTS[32975] = Fluid3D([9093,8365,9011,9336],0); -ELEMENTS[32976] = Fluid3D([16845,16833,17198,17147],0); -ELEMENTS[32977] = Fluid3D([15415,14701,15116,15463],0); -ELEMENTS[32978] = Fluid3D([16400,16644,16121,16545],0); -ELEMENTS[32979] = Fluid3D([16400,16644,16545,16922],0); -ELEMENTS[32980] = Fluid3D([16121,16400,16545,16451],0); -ELEMENTS[32981] = Fluid3D([16644,16121,16545,16516],0); -ELEMENTS[32982] = Fluid3D([16121,16545,16516,15994],0); -ELEMENTS[32983] = Fluid3D([16545,16644,16516,17009],0); -ELEMENTS[32984] = Fluid3D([13160,13937,13785,13334],0); -ELEMENTS[32985] = Fluid3D([3114,3125,2854,3415],0); -ELEMENTS[32986] = Fluid3D([17217,17379,17333,17533],0); -ELEMENTS[32987] = Fluid3D([17217,17379,17533,17470],0); -ELEMENTS[32988] = Fluid3D([17379,17333,17533,17720],0); -ELEMENTS[32989] = Fluid3D([17333,17217,17533,17469],0); -ELEMENTS[32990] = Fluid3D([17217,17533,17469,17470],0); -ELEMENTS[32991] = Fluid3D([11748,11012,11986,11439],0); -ELEMENTS[32992] = Fluid3D([9684,9200,8912,9165],0); -ELEMENTS[32993] = Fluid3D([12575,11760,12331,12254],0); -ELEMENTS[32994] = Fluid3D([11760,12331,12254,11840],0); -ELEMENTS[32995] = Fluid3D([12575,11760,12254,11657],0); -ELEMENTS[32996] = Fluid3D([11760,12254,11657,11009],0); -ELEMENTS[32997] = Fluid3D([12254,11760,11840,11009],0); -ELEMENTS[32998] = Fluid3D([17280,16988,16772,16675],0); -ELEMENTS[32999] = Fluid3D([16988,16772,16675,16579],0); -ELEMENTS[33000] = Fluid3D([12463,13094,12893,12194],0); -ELEMENTS[33001] = Fluid3D([9179,10105,9832,9652],0); -ELEMENTS[33002] = Fluid3D([9033,8667,8590,7867],0); -ELEMENTS[33003] = Fluid3D([13765,13951,14216,13274],0); -ELEMENTS[33004] = Fluid3D([6692,6230,6412,5845],0); -ELEMENTS[33005] = Fluid3D([8545,8308,7542,8509],0); -ELEMENTS[33006] = Fluid3D([9863,9384,8928,8962],0); -ELEMENTS[33007] = Fluid3D([14983,14371,14343,14665],0); -ELEMENTS[33008] = Fluid3D([13077,13135,12292,12476],0); -ELEMENTS[33009] = Fluid3D([15196,14861,14579,14487],0); -ELEMENTS[33010] = Fluid3D([8224,8751,7777,8163],0); -ELEMENTS[33011] = Fluid3D([5530,6197,5830,5993],0); -ELEMENTS[33012] = Fluid3D([2258,2152,2083,2037],0); -ELEMENTS[33013] = Fluid3D([2258,2152,2037,2289],0); -ELEMENTS[33014] = Fluid3D([2083,2258,2037,1977],0); -ELEMENTS[33015] = Fluid3D([2152,2083,2037,1915],0); -ELEMENTS[33016] = Fluid3D([10985,11364,11182,11805],0); -ELEMENTS[33017] = Fluid3D([10985,11364,11805,11042],0); -ELEMENTS[33018] = Fluid3D([11364,11182,11805,11900],0); -ELEMENTS[33019] = Fluid3D([11182,10985,11805,11775],0); -ELEMENTS[33020] = Fluid3D([11805,10985,11042,11419],0); -ELEMENTS[33021] = Fluid3D([10985,11805,11775,11419],0); -ELEMENTS[33022] = Fluid3D([16013,15403,15878,15986],0); -ELEMENTS[33023] = Fluid3D([9572,9529,9189,10399],0); -ELEMENTS[33024] = Fluid3D([15023,15638,15578,14997],0); -ELEMENTS[33025] = Fluid3D([15612,15835,15516,16019],0); -ELEMENTS[33026] = Fluid3D([17484,17341,17076,17282],0); -ELEMENTS[33027] = Fluid3D([17341,17076,17282,16870],0); -ELEMENTS[33028] = Fluid3D([2914,3018,2957,2738],0); -ELEMENTS[33029] = Fluid3D([13484,13456,13027,14195],0); -ELEMENTS[33030] = Fluid3D([5778,5741,6153,5367],0); -ELEMENTS[33031] = Fluid3D([9748,10005,10538,10469],0); -ELEMENTS[33032] = Fluid3D([10538,9748,10469,10376],0); -ELEMENTS[33033] = Fluid3D([9748,10469,10376,10337],0); -ELEMENTS[33034] = Fluid3D([10538,9748,10376,9660],0); -ELEMENTS[33035] = Fluid3D([15387,14733,15205,15517],0); -ELEMENTS[33036] = Fluid3D([15387,14733,15517,15131],0); -ELEMENTS[33037] = Fluid3D([2425,2747,2550,2636],0); -ELEMENTS[33038] = Fluid3D([2425,2747,2636,2846],0); -ELEMENTS[33039] = Fluid3D([2747,2550,2636,2804],0); -ELEMENTS[33040] = Fluid3D([2550,2425,2636,2310],0); -ELEMENTS[33041] = Fluid3D([2550,2425,2310,2207],0); -ELEMENTS[33042] = Fluid3D([2636,2550,2310,2384],0); -ELEMENTS[33043] = Fluid3D([2425,2636,2310,2384],0); -ELEMENTS[33044] = Fluid3D([14204,14740,14627,15113],0); -ELEMENTS[33045] = Fluid3D([4348,4747,4330,4312],0); -ELEMENTS[33046] = Fluid3D([9086,9180,9266,8374],0); -ELEMENTS[33047] = Fluid3D([17777,17397,17660,17450],0); -ELEMENTS[33048] = Fluid3D([11593,12385,11735,12324],0); -ELEMENTS[33049] = Fluid3D([11735,11593,12324,11416],0); -ELEMENTS[33050] = Fluid3D([11593,12324,11416,11941],0); -ELEMENTS[33051] = Fluid3D([11593,12385,12324,12664],0); -ELEMENTS[33052] = Fluid3D([12324,11593,12664,11941],0); -ELEMENTS[33053] = Fluid3D([12324,11735,11416,11785],0); -ELEMENTS[33054] = Fluid3D([11416,12324,11785,11941],0); -ELEMENTS[33055] = Fluid3D([11735,11593,11416,10514],0); -ELEMENTS[33056] = Fluid3D([11735,11416,11785,10858],0); -ELEMENTS[33057] = Fluid3D([11416,11785,10858,11215],0); -ELEMENTS[33058] = Fluid3D([11416,11785,11215,11941],0); -ELEMENTS[33059] = Fluid3D([10656,9999,10753,10048],0); -ELEMENTS[33060] = Fluid3D([7905,7578,7486,7043],0); -ELEMENTS[33061] = Fluid3D([5069,5151,4608,4992],0); -ELEMENTS[33062] = Fluid3D([5069,5151,4992,5663],0); -ELEMENTS[33063] = Fluid3D([4608,5069,4992,4339],0); -ELEMENTS[33064] = Fluid3D([5151,4608,4992,4558],0); -ELEMENTS[33065] = Fluid3D([7081,6871,6278,6299],0); -ELEMENTS[33066] = Fluid3D([18302,18371,18102,18351],0); -ELEMENTS[33067] = Fluid3D([3440,3469,3805,3398],0); -ELEMENTS[33068] = Fluid3D([3440,3469,3398,3036],0); -ELEMENTS[33069] = Fluid3D([3469,3805,3398,3797],0); -ELEMENTS[33070] = Fluid3D([3805,3440,3398,3511],0); -ELEMENTS[33071] = Fluid3D([5512,5894,5549,5807],0); -ELEMENTS[33072] = Fluid3D([10266,10803,10918,10003],0); -ELEMENTS[33073] = Fluid3D([12850,13194,13098,13823],0); -ELEMENTS[33074] = Fluid3D([16830,16365,16560,16385],0); -ELEMENTS[33075] = Fluid3D([4715,5211,4839,4777],0); -ELEMENTS[33076] = Fluid3D([4715,5211,4777,5046],0); -ELEMENTS[33077] = Fluid3D([4839,4715,4777,4159],0); -ELEMENTS[33078] = Fluid3D([5211,4839,4777,5304],0); -ELEMENTS[33079] = Fluid3D([6149,5790,6254,6571],0); -ELEMENTS[33080] = Fluid3D([9519,9190,9710,10293],0); -ELEMENTS[33081] = Fluid3D([9710,9519,10293,10336],0); -ELEMENTS[33082] = Fluid3D([15836,15510,16227,16000],0); -ELEMENTS[33083] = Fluid3D([13222,13474,12531,12672],0); -ELEMENTS[33084] = Fluid3D([7106,7854,7158,6987],0); -ELEMENTS[33085] = Fluid3D([7427,6707,7233,7599],0); -ELEMENTS[33086] = Fluid3D([6707,7233,7599,6472],0); -ELEMENTS[33087] = Fluid3D([14395,14521,14883,14039],0); -ELEMENTS[33088] = Fluid3D([15828,15558,15188,15674],0); -ELEMENTS[33089] = Fluid3D([11641,11893,11717,12527],0); -ELEMENTS[33090] = Fluid3D([11717,11641,12527,11901],0); -ELEMENTS[33091] = Fluid3D([11893,11717,12527,12298],0); -ELEMENTS[33092] = Fluid3D([11641,11893,12527,12478],0); -ELEMENTS[33093] = Fluid3D([4587,4242,4171,3977],0); -ELEMENTS[33094] = Fluid3D([6002,5872,6192,6779],0); -ELEMENTS[33095] = Fluid3D([14880,15391,14882,15362],0); -ELEMENTS[33096] = Fluid3D([12088,12147,12884,12507],0); -ELEMENTS[33097] = Fluid3D([12364,13183,12433,12029],0); -ELEMENTS[33098] = Fluid3D([15541,15470,15072,15689],0); -ELEMENTS[33099] = Fluid3D([15072,15541,15689,15359],0); -ELEMENTS[33100] = Fluid3D([15689,15072,15359,15668],0); -ELEMENTS[33101] = Fluid3D([15359,15689,15668,16024],0); -ELEMENTS[33102] = Fluid3D([15359,15689,16024,15541],0); -ELEMENTS[33103] = Fluid3D([15689,15668,16024,16149],0); -ELEMENTS[33104] = Fluid3D([15541,15470,15689,16078],0); -ELEMENTS[33105] = Fluid3D([15470,15072,15689,15668],0); -ELEMENTS[33106] = Fluid3D([12128,11767,12736,11918],0); -ELEMENTS[33107] = Fluid3D([3023,3307,2948,3044],0); -ELEMENTS[33108] = Fluid3D([3307,2948,3044,3296],0); -ELEMENTS[33109] = Fluid3D([3044,3307,3296,3227],0); -ELEMENTS[33110] = Fluid3D([3296,3044,3227,3109],0); -ELEMENTS[33111] = Fluid3D([2948,3023,3044,2674],0); -ELEMENTS[33112] = Fluid3D([3023,3307,3044,3227],0); -ELEMENTS[33113] = Fluid3D([16032,16246,16000,16340],0); -ELEMENTS[33114] = Fluid3D([16000,16032,16340,15909],0); -ELEMENTS[33115] = Fluid3D([16340,16000,15909,16369],0); -ELEMENTS[33116] = Fluid3D([16000,15909,16369,15836],0); -ELEMENTS[33117] = Fluid3D([15909,16369,15836,16368],0); -ELEMENTS[33118] = Fluid3D([16340,16000,16369,16513],0); -ELEMENTS[33119] = Fluid3D([15909,16340,16369,16527],0); -ELEMENTS[33120] = Fluid3D([16032,16246,16340,16783],0); -ELEMENTS[33121] = Fluid3D([16852,17082,17297,17004],0); -ELEMENTS[33122] = Fluid3D([16852,17082,17004,16614],0); -ELEMENTS[33123] = Fluid3D([17297,16852,17004,17067],0); -ELEMENTS[33124] = Fluid3D([17004,17297,17067,17292],0); -ELEMENTS[33125] = Fluid3D([17067,17004,17292,16961],0); -ELEMENTS[33126] = Fluid3D([16852,17004,17067,16607],0); -ELEMENTS[33127] = Fluid3D([17004,17067,16607,16961],0); -ELEMENTS[33128] = Fluid3D([16852,17004,16607,16614],0); -ELEMENTS[33129] = Fluid3D([12520,13147,12248,12670],0); -ELEMENTS[33130] = Fluid3D([12520,13147,12670,13550],0); -ELEMENTS[33131] = Fluid3D([12248,12520,12670,11786],0); -ELEMENTS[33132] = Fluid3D([12520,12670,11786,12506],0); -ELEMENTS[33133] = Fluid3D([12248,12520,11786,11647],0); -ELEMENTS[33134] = Fluid3D([12520,11786,11647,11835],0); -ELEMENTS[33135] = Fluid3D([10636,10942,10456,9905],0); -ELEMENTS[33136] = Fluid3D([14430,13747,14363,14657],0); -ELEMENTS[33137] = Fluid3D([9110,8799,8210,8306],0); -ELEMENTS[33138] = Fluid3D([17759,17532,17619,17875],0); -ELEMENTS[33139] = Fluid3D([3363,3236,3386,2806],0); -ELEMENTS[33140] = Fluid3D([16576,16504,16900,17136],0); -ELEMENTS[33141] = Fluid3D([15720,15666,15642,16254],0); -ELEMENTS[33142] = Fluid3D([8411,8774,8863,7871],0); -ELEMENTS[33143] = Fluid3D([12079,12491,12803,12234],0); -ELEMENTS[33144] = Fluid3D([10749,10351,10541,11866],0); -ELEMENTS[33145] = Fluid3D([3505,3494,3772,4136],0); -ELEMENTS[33146] = Fluid3D([8945,9837,9392,9177],0); -ELEMENTS[33147] = Fluid3D([16675,16272,16297,16778],0); -ELEMENTS[33148] = Fluid3D([13897,14666,13981,14394],0); -ELEMENTS[33149] = Fluid3D([9798,10555,10621,10210],0); -ELEMENTS[33150] = Fluid3D([3762,4063,3583,3864],0); -ELEMENTS[33151] = Fluid3D([4656,4997,4384,4830],0); -ELEMENTS[33152] = Fluid3D([11951,11997,11932,12767],0); -ELEMENTS[33153] = Fluid3D([8501,9178,8849,8309],0); -ELEMENTS[33154] = Fluid3D([14599,13944,13872,13645],0); -ELEMENTS[33155] = Fluid3D([10975,11030,11158,11743],0); -ELEMENTS[33156] = Fluid3D([11030,11158,11743,11921],0); -ELEMENTS[33157] = Fluid3D([10975,11030,11743,11665],0); -ELEMENTS[33158] = Fluid3D([11158,10975,11743,12095],0); -ELEMENTS[33159] = Fluid3D([10975,11743,12095,11961],0); -ELEMENTS[33160] = Fluid3D([11743,11158,12095,12266],0); -ELEMENTS[33161] = Fluid3D([10703,9908,11016,11124],0); -ELEMENTS[33162] = Fluid3D([16597,16636,16544,16964],0); -ELEMENTS[33163] = Fluid3D([16544,16597,16964,16548],0); -ELEMENTS[33164] = Fluid3D([16544,16597,16548,16025],0); -ELEMENTS[33165] = Fluid3D([16964,16544,16548,17008],0); -ELEMENTS[33166] = Fluid3D([16544,16548,17008,16648],0); -ELEMENTS[33167] = Fluid3D([16548,16544,16025,16131],0); -ELEMENTS[33168] = Fluid3D([16636,16544,16964,16968],0); -ELEMENTS[33169] = Fluid3D([16597,16636,16964,17109],0); -ELEMENTS[33170] = Fluid3D([16544,16548,16648,16131],0); -ELEMENTS[33171] = Fluid3D([16167,16322,15900,16515],0); -ELEMENTS[33172] = Fluid3D([3591,3846,3503,4067],0); -ELEMENTS[33173] = Fluid3D([13207,13085,12538,12891],0); -ELEMENTS[33174] = Fluid3D([13507,13102,12845,13859],0); -ELEMENTS[33175] = Fluid3D([13507,13102,13859,14304],0); -ELEMENTS[33176] = Fluid3D([12845,13507,13859,13697],0); -ELEMENTS[33177] = Fluid3D([13102,12845,13859,12747],0); -ELEMENTS[33178] = Fluid3D([6531,6904,6018,7031],0); -ELEMENTS[33179] = Fluid3D([7409,7129,7363,8204],0); -ELEMENTS[33180] = Fluid3D([11782,10820,11551,11560],0); -ELEMENTS[33181] = Fluid3D([18501,18602,18561,18631],0); -ELEMENTS[33182] = Fluid3D([3259,3360,3128,2979],0); -ELEMENTS[33183] = Fluid3D([3360,3128,2979,3049],0); -ELEMENTS[33184] = Fluid3D([3259,3360,2979,3090],0); -ELEMENTS[33185] = Fluid3D([3128,2979,3049,2710],0); -ELEMENTS[33186] = Fluid3D([3128,3259,2979,2880],0); -ELEMENTS[33187] = Fluid3D([3259,2979,2880,3090],0); -ELEMENTS[33188] = Fluid3D([2979,2880,3090,2763],0); -ELEMENTS[33189] = Fluid3D([2979,2880,2763,2590],0); -ELEMENTS[33190] = Fluid3D([3090,2979,2763,2962],0); -ELEMENTS[33191] = Fluid3D([3360,3128,3049,3616],0); -ELEMENTS[33192] = Fluid3D([2979,3360,3049,3292],0); -ELEMENTS[33193] = Fluid3D([10815,11283,10689,11942],0); -ELEMENTS[33194] = Fluid3D([12658,12517,12880,12123],0); -ELEMENTS[33195] = Fluid3D([17608,17755,17946,17638],0); -ELEMENTS[33196] = Fluid3D([9811,10637,9894,9835],0); -ELEMENTS[33197] = Fluid3D([14975,15497,15485,15246],0); -ELEMENTS[33198] = Fluid3D([5486,4939,5065,5473],0); -ELEMENTS[33199] = Fluid3D([8783,8217,8820,7972],0); -ELEMENTS[33200] = Fluid3D([8783,8217,7972,7992],0); -ELEMENTS[33201] = Fluid3D([7972,8783,7992,8492],0); -ELEMENTS[33202] = Fluid3D([8217,7972,7992,7005],0); -ELEMENTS[33203] = Fluid3D([14219,13370,13873,14200],0); -ELEMENTS[33204] = Fluid3D([13370,13873,14200,13998],0); -ELEMENTS[33205] = Fluid3D([14200,13370,13998,14011],0); -ELEMENTS[33206] = Fluid3D([13998,14200,14011,14693],0); -ELEMENTS[33207] = Fluid3D([14011,13998,14693,14067],0); -ELEMENTS[33208] = Fluid3D([14011,13998,14067,13248],0); -ELEMENTS[33209] = Fluid3D([14011,13998,13248,13370],0); -ELEMENTS[33210] = Fluid3D([13998,14200,14693,14733],0); -ELEMENTS[33211] = Fluid3D([14200,14011,14693,14548],0); -ELEMENTS[33212] = Fluid3D([14200,14011,14548,13370],0); -ELEMENTS[33213] = Fluid3D([13998,14693,14067,14741],0); -ELEMENTS[33214] = Fluid3D([14693,13998,14733,14342],0); -ELEMENTS[33215] = Fluid3D([14693,14011,14067,14561],0); -ELEMENTS[33216] = Fluid3D([14693,14200,14548,14733],0); -ELEMENTS[33217] = Fluid3D([14693,14067,14741,14561],0); -ELEMENTS[33218] = Fluid3D([14693,14011,14561,15015],0); -ELEMENTS[33219] = Fluid3D([14011,14067,14561,13669],0); -ELEMENTS[33220] = Fluid3D([13873,14219,14200,14451],0); -ELEMENTS[33221] = Fluid3D([14200,13873,14451,13998],0); -ELEMENTS[33222] = Fluid3D([14451,14200,13998,14733],0); -ELEMENTS[33223] = Fluid3D([14451,14200,14733,14548],0); -ELEMENTS[33224] = Fluid3D([14451,14200,14548,14219],0); -ELEMENTS[33225] = Fluid3D([14200,14548,14219,13370],0); -ELEMENTS[33226] = Fluid3D([14067,14741,14561,13669],0); -ELEMENTS[33227] = Fluid3D([10970,10854,11616,11526],0); -ELEMENTS[33228] = Fluid3D([13291,13109,12472,12711],0); -ELEMENTS[33229] = Fluid3D([5459,6072,5757,5888],0); -ELEMENTS[33230] = Fluid3D([5459,6072,5888,5605],0); -ELEMENTS[33231] = Fluid3D([6072,5757,5888,6262],0); -ELEMENTS[33232] = Fluid3D([6072,5757,6262,6645],0); -ELEMENTS[33233] = Fluid3D([5888,6072,6262,6412],0); -ELEMENTS[33234] = Fluid3D([6262,5888,6412,6196],0); -ELEMENTS[33235] = Fluid3D([6412,6262,6196,6910],0); -ELEMENTS[33236] = Fluid3D([6262,6196,6910,6982],0); -ELEMENTS[33237] = Fluid3D([6412,6262,6910,6072],0); -ELEMENTS[33238] = Fluid3D([6262,5888,6196,5757],0); -ELEMENTS[33239] = Fluid3D([6262,6196,6982,6116],0); -ELEMENTS[33240] = Fluid3D([6262,6910,6072,6645],0); -ELEMENTS[33241] = Fluid3D([6196,6262,5757,6116],0); -ELEMENTS[33242] = Fluid3D([5757,5459,5888,5261],0); -ELEMENTS[33243] = Fluid3D([5459,5888,5261,5605],0); -ELEMENTS[33244] = Fluid3D([5888,5757,5261,5626],0); -ELEMENTS[33245] = Fluid3D([5757,5459,5261,5152],0); -ELEMENTS[33246] = Fluid3D([16524,16622,16174,16638],0); -ELEMENTS[33247] = Fluid3D([7827,7897,7223,8103],0); -ELEMENTS[33248] = Fluid3D([12846,12645,12327,13393],0); -ELEMENTS[33249] = Fluid3D([15188,15394,15344,14488],0); -ELEMENTS[33250] = Fluid3D([15604,15234,15765,15106],0); -ELEMENTS[33251] = Fluid3D([15234,15765,15106,15419],0); -ELEMENTS[33252] = Fluid3D([15859,15628,15204,15369],0); -ELEMENTS[33253] = Fluid3D([14264,14553,14474,14889],0); -ELEMENTS[33254] = Fluid3D([14264,14553,14889,14768],0); -ELEMENTS[33255] = Fluid3D([14474,14264,14889,14563],0); -ELEMENTS[33256] = Fluid3D([14553,14474,14889,15028],0); -ELEMENTS[33257] = Fluid3D([14474,14889,15028,14563],0); -ELEMENTS[33258] = Fluid3D([15028,14474,14563,14737],0); -ELEMENTS[33259] = Fluid3D([14474,14264,14563,13707],0); -ELEMENTS[33260] = Fluid3D([14563,14474,13707,14737],0); -ELEMENTS[33261] = Fluid3D([14264,14889,14563,14410],0); -ELEMENTS[33262] = Fluid3D([14264,14889,14410,14768],0); -ELEMENTS[33263] = Fluid3D([14563,14264,14410,13707],0); -ELEMENTS[33264] = Fluid3D([14410,14264,14768,13925],0); -ELEMENTS[33265] = Fluid3D([3304,3122,3546,3334],0); -ELEMENTS[33266] = Fluid3D([17417,17549,17722,17813],0); -ELEMENTS[33267] = Fluid3D([7604,7287,7260,6536],0); -ELEMENTS[33268] = Fluid3D([11801,12206,11898,13099],0); -ELEMENTS[33269] = Fluid3D([13122,13325,13976,13489],0); -ELEMENTS[33270] = Fluid3D([12994,13930,13095,13137],0); -ELEMENTS[33271] = Fluid3D([3260,3766,3799,3741],0); -ELEMENTS[33272] = Fluid3D([9477,9665,9374,8815],0); -ELEMENTS[33273] = Fluid3D([9665,9374,8815,9174],0); -ELEMENTS[33274] = Fluid3D([8970,8378,9225,8784],0); -ELEMENTS[33275] = Fluid3D([8378,9225,8784,8821],0); -ELEMENTS[33276] = Fluid3D([13394,13358,14118,13986],0); -ELEMENTS[33277] = Fluid3D([5765,6366,6140,5897],0); -ELEMENTS[33278] = Fluid3D([7272,8102,7432,7443],0); -ELEMENTS[33279] = Fluid3D([9555,8607,9117,9236],0); -ELEMENTS[33280] = Fluid3D([7156,7171,7133,6370],0); -ELEMENTS[33281] = Fluid3D([13144,12572,12209,13185],0); -ELEMENTS[33282] = Fluid3D([15196,15182,14854,14579],0); -ELEMENTS[33283] = Fluid3D([10781,11456,11186,10243],0); -ELEMENTS[33284] = Fluid3D([10214,9934,10452,10754],0); -ELEMENTS[33285] = Fluid3D([9934,10452,10754,10228],0); -ELEMENTS[33286] = Fluid3D([7024,6197,6677,6388],0); -ELEMENTS[33287] = Fluid3D([2465,2234,2406,2420],0); -ELEMENTS[33288] = Fluid3D([2406,2465,2420,2705],0); -ELEMENTS[33289] = Fluid3D([10959,11364,10612,11820],0); -ELEMENTS[33290] = Fluid3D([15854,16215,16035,15617],0); -ELEMENTS[33291] = Fluid3D([8770,9474,8648,9255],0); -ELEMENTS[33292] = Fluid3D([9474,8648,9255,9597],0); -ELEMENTS[33293] = Fluid3D([8648,8770,9255,8323],0); -ELEMENTS[33294] = Fluid3D([8648,8770,8323,7844],0); -ELEMENTS[33295] = Fluid3D([9255,8648,8323,8379],0); -ELEMENTS[33296] = Fluid3D([8770,9474,9255,9567],0); -ELEMENTS[33297] = Fluid3D([8770,9255,8323,9191],0); -ELEMENTS[33298] = Fluid3D([15904,16214,16251,16635],0); -ELEMENTS[33299] = Fluid3D([16270,16436,16723,16933],0); -ELEMENTS[33300] = Fluid3D([16490,15968,16384,16350],0); -ELEMENTS[33301] = Fluid3D([3124,3319,3246,2914],0); -ELEMENTS[33302] = Fluid3D([15216,15473,14967,15652],0); -ELEMENTS[33303] = Fluid3D([5340,4936,5545,5205],0); -ELEMENTS[33304] = Fluid3D([17811,17615,17677,17939],0); -ELEMENTS[33305] = Fluid3D([17615,17677,17939,17700],0); -ELEMENTS[33306] = Fluid3D([17939,17615,17700,17740],0); -ELEMENTS[33307] = Fluid3D([17615,17700,17740,17352],0); -ELEMENTS[33308] = Fluid3D([17700,17740,17352,17627],0); -ELEMENTS[33309] = Fluid3D([17615,17700,17352,17254],0); -ELEMENTS[33310] = Fluid3D([17677,17811,17939,18100],0); -ELEMENTS[33311] = Fluid3D([17811,17615,17939,17832],0); -ELEMENTS[33312] = Fluid3D([11007,12017,11944,11872],0); -ELEMENTS[33313] = Fluid3D([13123,12828,12222,12330],0); -ELEMENTS[33314] = Fluid3D([12664,11593,11777,11941],0); -ELEMENTS[33315] = Fluid3D([16702,16594,16403,17015],0); -ELEMENTS[33316] = Fluid3D([14441,14810,14936,15206],0); -ELEMENTS[33317] = Fluid3D([3840,3482,3986,3609],0); -ELEMENTS[33318] = Fluid3D([14494,14305,13844,14336],0); -ELEMENTS[33319] = Fluid3D([17219,17288,16979,17407],0); -ELEMENTS[33320] = Fluid3D([16979,17219,17407,17117],0); -ELEMENTS[33321] = Fluid3D([17219,17288,17407,17641],0); -ELEMENTS[33322] = Fluid3D([17219,17407,17117,17455],0); -ELEMENTS[33323] = Fluid3D([17407,17117,17455,17300],0); -ELEMENTS[33324] = Fluid3D([17407,16979,17117,17121],0); -ELEMENTS[33325] = Fluid3D([17407,16979,17121,17226],0); -ELEMENTS[33326] = Fluid3D([17121,17407,17226,17583],0); -ELEMENTS[33327] = Fluid3D([17121,17407,17583,17300],0); -ELEMENTS[33328] = Fluid3D([17226,17121,17583,17440],0); -ELEMENTS[33329] = Fluid3D([17226,17121,17440,16798],0); -ELEMENTS[33330] = Fluid3D([17226,17121,16798,16979],0); -ELEMENTS[33331] = Fluid3D([17117,17407,17121,17300],0); -ELEMENTS[33332] = Fluid3D([16979,17117,17121,16601],0); -ELEMENTS[33333] = Fluid3D([17288,16979,17407,17312],0); -ELEMENTS[33334] = Fluid3D([16979,17219,17117,16599],0); -ELEMENTS[33335] = Fluid3D([10920,10524,11519,10681],0); -ELEMENTS[33336] = Fluid3D([8666,7953,8021,8968],0); -ELEMENTS[33337] = Fluid3D([10590,11167,10800,10641],0); -ELEMENTS[33338] = Fluid3D([12179,12920,12118,12175],0); -ELEMENTS[33339] = Fluid3D([7557,8359,7581,8033],0); -ELEMENTS[33340] = Fluid3D([7557,8359,8033,8375],0); -ELEMENTS[33341] = Fluid3D([8033,7557,8375,7381],0); -ELEMENTS[33342] = Fluid3D([8033,7557,7381,7155],0); -ELEMENTS[33343] = Fluid3D([8375,8033,7381,8276],0); -ELEMENTS[33344] = Fluid3D([8033,7557,7155,7581],0); -ELEMENTS[33345] = Fluid3D([9544,9013,9306,8412],0); -ELEMENTS[33346] = Fluid3D([13773,13433,14025,12767],0); -ELEMENTS[33347] = Fluid3D([6187,6340,5784,6652],0); -ELEMENTS[33348] = Fluid3D([12661,12159,12813,11979],0); -ELEMENTS[33349] = Fluid3D([12661,12159,11979,11716],0); -ELEMENTS[33350] = Fluid3D([12813,12661,11979,13024],0); -ELEMENTS[33351] = Fluid3D([12159,12813,11979,12128],0); -ELEMENTS[33352] = Fluid3D([5169,5845,5684,5600],0); -ELEMENTS[33353] = Fluid3D([10010,9761,9135,9114],0); -ELEMENTS[33354] = Fluid3D([9135,10010,9114,9682],0); -ELEMENTS[33355] = Fluid3D([10010,9761,9114,9298],0); -ELEMENTS[33356] = Fluid3D([9130,9356,10089,9546],0); -ELEMENTS[33357] = Fluid3D([10369,9384,10110,9329],0); -ELEMENTS[33358] = Fluid3D([16178,15625,15802,15840],0); -ELEMENTS[33359] = Fluid3D([15996,15813,16096,15407],0); -ELEMENTS[33360] = Fluid3D([13598,13454,12980,13688],0); -ELEMENTS[33361] = Fluid3D([13454,12980,13688,12606],0); -ELEMENTS[33362] = Fluid3D([12980,13688,12606,12303],0); -ELEMENTS[33363] = Fluid3D([9408,9510,10142,10630],0); -ELEMENTS[33364] = Fluid3D([10142,9408,10630,10612],0); -ELEMENTS[33365] = Fluid3D([10630,10142,10612,11135],0); -ELEMENTS[33366] = Fluid3D([10630,10142,11135,10928],0); -ELEMENTS[33367] = Fluid3D([10612,10630,11135,11364],0); -ELEMENTS[33368] = Fluid3D([10630,11135,11364,11042],0); -ELEMENTS[33369] = Fluid3D([10630,11135,11042,10928],0); -ELEMENTS[33370] = Fluid3D([5429,5201,4887,4803],0); -ELEMENTS[33371] = Fluid3D([4887,5429,4803,5032],0); -ELEMENTS[33372] = Fluid3D([5201,4887,4803,4907],0); -ELEMENTS[33373] = Fluid3D([2171,2311,2326,2152],0); -ELEMENTS[33374] = Fluid3D([5893,5269,5602,5348],0); -ELEMENTS[33375] = Fluid3D([11004,10080,10772,10727],0); -ELEMENTS[33376] = Fluid3D([14581,14716,14717,13949],0); -ELEMENTS[33377] = Fluid3D([12441,13319,13125,13166],0); -ELEMENTS[33378] = Fluid3D([13199,13644,13462,12753],0); -ELEMENTS[33379] = Fluid3D([6944,7860,7753,7258],0); -ELEMENTS[33380] = Fluid3D([12464,13249,12909,12540],0); -ELEMENTS[33381] = Fluid3D([6179,5806,6062,6339],0); -ELEMENTS[33382] = Fluid3D([13625,13554,13588,12635],0); -ELEMENTS[33383] = Fluid3D([8189,8981,8348,8311],0); -ELEMENTS[33384] = Fluid3D([8981,8348,8311,8790],0); -ELEMENTS[33385] = Fluid3D([8348,8311,8790,7970],0); -ELEMENTS[33386] = Fluid3D([11394,11129,10390,11267],0); -ELEMENTS[33387] = Fluid3D([11443,11536,11857,12131],0); -ELEMENTS[33388] = Fluid3D([11443,11536,12131,10908],0); -ELEMENTS[33389] = Fluid3D([11857,11443,12131,12231],0); -ELEMENTS[33390] = Fluid3D([12131,11443,10908,11256],0); -ELEMENTS[33391] = Fluid3D([12131,11443,11256,12203],0); -ELEMENTS[33392] = Fluid3D([16449,16826,16580,16978],0); -ELEMENTS[33393] = Fluid3D([4490,4040,4039,4129],0); -ELEMENTS[33394] = Fluid3D([11866,12076,11460,11374],0); -ELEMENTS[33395] = Fluid3D([10263,10887,10711,11097],0); -ELEMENTS[33396] = Fluid3D([10263,10887,11097,10558],0); -ELEMENTS[33397] = Fluid3D([10887,10711,11097,11769],0); -ELEMENTS[33398] = Fluid3D([10711,10263,11097,11062],0); -ELEMENTS[33399] = Fluid3D([12749,13238,13364,12277],0); -ELEMENTS[33400] = Fluid3D([7666,7466,7866,6736],0); -ELEMENTS[33401] = Fluid3D([10167,9373,9321,9083],0); -ELEMENTS[33402] = Fluid3D([3893,4130,3668,4288],0); -ELEMENTS[33403] = Fluid3D([6532,7188,6805,7112],0); -ELEMENTS[33404] = Fluid3D([6532,7188,7112,7079],0); -ELEMENTS[33405] = Fluid3D([15704,16242,15880,15519],0); -ELEMENTS[33406] = Fluid3D([16242,15880,15519,16006],0); -ELEMENTS[33407] = Fluid3D([15880,15519,16006,15461],0); -ELEMENTS[33408] = Fluid3D([15880,15704,15519,14915],0); -ELEMENTS[33409] = Fluid3D([15704,16242,15519,15686],0); -ELEMENTS[33410] = Fluid3D([15519,16006,15461,15452],0); -ELEMENTS[33411] = Fluid3D([15519,16006,15452,16113],0); -ELEMENTS[33412] = Fluid3D([15461,15519,15452,15031],0); -ELEMENTS[33413] = Fluid3D([15519,15452,15031,15428],0); -ELEMENTS[33414] = Fluid3D([15452,15461,15031,15441],0); -ELEMENTS[33415] = Fluid3D([15461,15519,15031,14915],0); -ELEMENTS[33416] = Fluid3D([16006,15461,15452,15441],0); -ELEMENTS[33417] = Fluid3D([16242,15880,16006,16483],0); -ELEMENTS[33418] = Fluid3D([15519,16242,16006,16113],0); -ELEMENTS[33419] = Fluid3D([15880,15519,15461,14915],0); -ELEMENTS[33420] = Fluid3D([16006,15880,15461,16293],0); -ELEMENTS[33421] = Fluid3D([6067,6908,6590,6875],0); -ELEMENTS[33422] = Fluid3D([13332,12737,13754,13139],0); -ELEMENTS[33423] = Fluid3D([13332,12737,13139,12233],0); -ELEMENTS[33424] = Fluid3D([13139,13332,12233,12373],0); -ELEMENTS[33425] = Fluid3D([13754,13332,13139,13809],0); -ELEMENTS[33426] = Fluid3D([12450,12683,11852,11922],0); -ELEMENTS[33427] = Fluid3D([12450,12683,11922,13072],0); -ELEMENTS[33428] = Fluid3D([11852,12450,11922,11548],0); -ELEMENTS[33429] = Fluid3D([12683,11852,11922,11861],0); -ELEMENTS[33430] = Fluid3D([4989,4421,4741,4560],0); -ELEMENTS[33431] = Fluid3D([3910,4185,3919,3603],0); -ELEMENTS[33432] = Fluid3D([8430,8845,8090,9179],0); -ELEMENTS[33433] = Fluid3D([7408,7903,8305,7567],0); -ELEMENTS[33434] = Fluid3D([14485,14691,14575,14822],0); -ELEMENTS[33435] = Fluid3D([14575,14485,14822,13914],0); -ELEMENTS[33436] = Fluid3D([14485,14691,14822,15502],0); -ELEMENTS[33437] = Fluid3D([14691,14575,14822,15502],0); -ELEMENTS[33438] = Fluid3D([14379,14049,13783,14617],0); -ELEMENTS[33439] = Fluid3D([13783,14379,14617,14321],0); -ELEMENTS[33440] = Fluid3D([14049,13783,14617,14191],0); -ELEMENTS[33441] = Fluid3D([13783,14617,14191,14321],0); -ELEMENTS[33442] = Fluid3D([14379,14049,14617,14798],0); -ELEMENTS[33443] = Fluid3D([5673,5923,5351,5855],0); -ELEMENTS[33444] = Fluid3D([6911,7761,7500,7461],0); -ELEMENTS[33445] = Fluid3D([17013,16698,16486,16724],0); -ELEMENTS[33446] = Fluid3D([16698,16486,16724,16342],0); -ELEMENTS[33447] = Fluid3D([16724,16698,16342,16915],0); -ELEMENTS[33448] = Fluid3D([16342,16724,16915,16471],0); -ELEMENTS[33449] = Fluid3D([16724,16915,16471,16941],0); -ELEMENTS[33450] = Fluid3D([16724,16915,16941,16951],0); -ELEMENTS[33451] = Fluid3D([16471,16724,16941,16951],0); -ELEMENTS[33452] = Fluid3D([16342,16724,16471,16486],0); -ELEMENTS[33453] = Fluid3D([16471,16724,16951,16486],0); -ELEMENTS[33454] = Fluid3D([16724,16951,16486,17013],0); -ELEMENTS[33455] = Fluid3D([16724,16951,17013,16915],0); -ELEMENTS[33456] = Fluid3D([16951,16486,17013,16827],0); -ELEMENTS[33457] = Fluid3D([17013,16698,16724,16915],0); -ELEMENTS[33458] = Fluid3D([13516,14374,13882,13606],0); -ELEMENTS[33459] = Fluid3D([15965,16132,16498,16586],0); -ELEMENTS[33460] = Fluid3D([4448,4705,4461,4144],0); -ELEMENTS[33461] = Fluid3D([11242,11177,11901,10829],0); -ELEMENTS[33462] = Fluid3D([15092,15678,15360,15108],0); -ELEMENTS[33463] = Fluid3D([7898,7491,8162,8220],0); -ELEMENTS[33464] = Fluid3D([11847,12455,12690,11978],0); -ELEMENTS[33465] = Fluid3D([15827,14818,15465,15400],0); -ELEMENTS[33466] = Fluid3D([15827,14818,15400,15245],0); -ELEMENTS[33467] = Fluid3D([15465,15827,15400,15959],0); -ELEMENTS[33468] = Fluid3D([15827,15400,15959,15921],0); -ELEMENTS[33469] = Fluid3D([15465,15827,15959,15945],0); -ELEMENTS[33470] = Fluid3D([15827,15959,15945,16415],0); -ELEMENTS[33471] = Fluid3D([15400,15827,15245,15921],0); -ELEMENTS[33472] = Fluid3D([10596,10457,10109,11118],0); -ELEMENTS[33473] = Fluid3D([13625,13588,14133,13258],0); -ELEMENTS[33474] = Fluid3D([13625,13588,13258,12635],0); -ELEMENTS[33475] = Fluid3D([14133,13625,13258,13743],0); -ELEMENTS[33476] = Fluid3D([14133,13625,13743,14482],0); -ELEMENTS[33477] = Fluid3D([13588,14133,13258,13810],0); -ELEMENTS[33478] = Fluid3D([13258,14133,13743,13713],0); -ELEMENTS[33479] = Fluid3D([13258,14133,13713,13126],0); -ELEMENTS[33480] = Fluid3D([13713,13258,13126,12899],0); -ELEMENTS[33481] = Fluid3D([13258,13126,12899,12310],0); -ELEMENTS[33482] = Fluid3D([13126,13713,12899,13171],0); -ELEMENTS[33483] = Fluid3D([13713,13258,12899,13743],0); -ELEMENTS[33484] = Fluid3D([13625,13258,13743,12955],0); -ELEMENTS[33485] = Fluid3D([13625,13258,12955,12310],0); -ELEMENTS[33486] = Fluid3D([13258,12955,12310,12899],0); -ELEMENTS[33487] = Fluid3D([13743,13625,12955,13077],0); -ELEMENTS[33488] = Fluid3D([13258,13743,12955,12899],0); -ELEMENTS[33489] = Fluid3D([14133,13743,13713,14488],0); -ELEMENTS[33490] = Fluid3D([13713,14133,14488,14107],0); -ELEMENTS[33491] = Fluid3D([14488,13713,14107,13335],0); -ELEMENTS[33492] = Fluid3D([13713,14133,14107,13126],0); -ELEMENTS[33493] = Fluid3D([14107,13713,13126,13171],0); -ELEMENTS[33494] = Fluid3D([14107,13713,13171,13335],0); -ELEMENTS[33495] = Fluid3D([13743,13713,14488,13335],0); -ELEMENTS[33496] = Fluid3D([3723,4019,3584,3815],0); -ELEMENTS[33497] = Fluid3D([6890,7041,6250,6559],0); -ELEMENTS[33498] = Fluid3D([10366,9649,9368,9990],0); -ELEMENTS[33499] = Fluid3D([13577,13592,14014,14300],0); -ELEMENTS[33500] = Fluid3D([13592,14014,14300,14445],0); -ELEMENTS[33501] = Fluid3D([14300,13592,14445,14259],0); -ELEMENTS[33502] = Fluid3D([14014,13577,14300,13913],0); -ELEMENTS[33503] = Fluid3D([13577,13592,14300,13428],0); -ELEMENTS[33504] = Fluid3D([13496,13747,12972,13846],0); -ELEMENTS[33505] = Fluid3D([9570,10373,9463,9618],0); -ELEMENTS[33506] = Fluid3D([18378,18219,18297,18045],0); -ELEMENTS[33507] = Fluid3D([12077,11037,11120,11203],0); -ELEMENTS[33508] = Fluid3D([12077,11037,11203,11392],0); -ELEMENTS[33509] = Fluid3D([5188,4609,4998,4913],0); -ELEMENTS[33510] = Fluid3D([5188,4609,4913,4747],0); -ELEMENTS[33511] = Fluid3D([4998,5188,4913,5509],0); -ELEMENTS[33512] = Fluid3D([5188,4913,5509,5217],0); -ELEMENTS[33513] = Fluid3D([4913,5509,5217,4858],0); -ELEMENTS[33514] = Fluid3D([5188,4913,5217,4747],0); -ELEMENTS[33515] = Fluid3D([4913,5217,4747,4858],0); -ELEMENTS[33516] = Fluid3D([5217,4747,4858,5484],0); -ELEMENTS[33517] = Fluid3D([5217,4747,5484,5340],0); -ELEMENTS[33518] = Fluid3D([5217,4747,5340,5205],0); -ELEMENTS[33519] = Fluid3D([5484,5217,5340,5576],0); -ELEMENTS[33520] = Fluid3D([5484,5217,5576,5509],0); -ELEMENTS[33521] = Fluid3D([5484,5217,5509,4858],0); -ELEMENTS[33522] = Fluid3D([5217,5576,5509,5188],0); -ELEMENTS[33523] = Fluid3D([5217,5576,5188,5205],0); -ELEMENTS[33524] = Fluid3D([4609,4998,4913,4492],0); -ELEMENTS[33525] = Fluid3D([4913,4609,4492,4074],0); -ELEMENTS[33526] = Fluid3D([4609,4998,4492,4250],0); -ELEMENTS[33527] = Fluid3D([4492,4609,4250,4074],0); -ELEMENTS[33528] = Fluid3D([4250,4492,4074,4265],0); -ELEMENTS[33529] = Fluid3D([4250,4492,4265,4619],0); -ELEMENTS[33530] = Fluid3D([4250,4492,4619,4998],0); -ELEMENTS[33531] = Fluid3D([4492,4074,4265,4508],0); -ELEMENTS[33532] = Fluid3D([4492,4074,4508,4913],0); -ELEMENTS[33533] = Fluid3D([4265,4492,4508,4692],0); -ELEMENTS[33534] = Fluid3D([4265,4492,4692,4619],0); -ELEMENTS[33535] = Fluid3D([4492,4692,4619,4998],0); -ELEMENTS[33536] = Fluid3D([4492,4508,4692,4913],0); -ELEMENTS[33537] = Fluid3D([4692,4265,4619,4475],0); -ELEMENTS[33538] = Fluid3D([4619,4692,4475,5022],0); -ELEMENTS[33539] = Fluid3D([4692,4475,5022,4740],0); -ELEMENTS[33540] = Fluid3D([4619,4692,5022,5476],0); -ELEMENTS[33541] = Fluid3D([4692,4265,4475,4135],0); -ELEMENTS[33542] = Fluid3D([4508,4265,4692,4135],0); -ELEMENTS[33543] = Fluid3D([4475,4619,5022,5018],0); -ELEMENTS[33544] = Fluid3D([5022,4475,5018,4879],0); -ELEMENTS[33545] = Fluid3D([4619,5022,5018,5476],0); -ELEMENTS[33546] = Fluid3D([4998,4913,4492,4692],0); -ELEMENTS[33547] = Fluid3D([4074,4265,4508,4053],0); -ELEMENTS[33548] = Fluid3D([4265,4508,4053,4135],0); -ELEMENTS[33549] = Fluid3D([4508,4074,4053,4330],0); -ELEMENTS[33550] = Fluid3D([4074,4265,4053,3905],0); -ELEMENTS[33551] = Fluid3D([4265,4475,4135,3905],0); -ELEMENTS[33552] = Fluid3D([4265,4475,3905,4619],0); -ELEMENTS[33553] = Fluid3D([4475,5022,4740,4879],0); -ELEMENTS[33554] = Fluid3D([4074,4250,4265,3905],0); -ELEMENTS[33555] = Fluid3D([4250,4265,3905,4619],0); -ELEMENTS[33556] = Fluid3D([17614,17489,17312,17682],0); -ELEMENTS[33557] = Fluid3D([17489,17312,17682,17307],0); -ELEMENTS[33558] = Fluid3D([17312,17614,17682,17730],0); -ELEMENTS[33559] = Fluid3D([17614,17489,17682,17867],0); -ELEMENTS[33560] = Fluid3D([15252,15965,15718,15468],0); -ELEMENTS[33561] = Fluid3D([15640,16064,16184,15548],0); -ELEMENTS[33562] = Fluid3D([17084,16916,16634,17240],0); -ELEMENTS[33563] = Fluid3D([12189,12782,11814,12336],0); -ELEMENTS[33564] = Fluid3D([12782,11814,12336,11984],0); -ELEMENTS[33565] = Fluid3D([11814,12189,12336,11128],0); -ELEMENTS[33566] = Fluid3D([12189,12782,12336,13278],0); -ELEMENTS[33567] = Fluid3D([4914,4723,5295,5223],0); -ELEMENTS[33568] = Fluid3D([3116,3404,3179,3600],0); -ELEMENTS[33569] = Fluid3D([10986,10363,11197,10524],0); -ELEMENTS[33570] = Fluid3D([11478,11167,12246,11887],0); -ELEMENTS[33571] = Fluid3D([8182,8978,9054,8734],0); -ELEMENTS[33572] = Fluid3D([8182,8978,8734,8209],0); -ELEMENTS[33573] = Fluid3D([8978,9054,8734,9853],0); -ELEMENTS[33574] = Fluid3D([9054,8182,8734,7811],0); -ELEMENTS[33575] = Fluid3D([10660,10597,10303,9533],0); -ELEMENTS[33576] = Fluid3D([3788,4282,4128,4110],0); -ELEMENTS[33577] = Fluid3D([14005,13648,13628,14694],0); -ELEMENTS[33578] = Fluid3D([6749,6618,6638,7538],0); -ELEMENTS[33579] = Fluid3D([13768,14171,13434,14278],0); -ELEMENTS[33580] = Fluid3D([10720,10876,9902,10666],0); -ELEMENTS[33581] = Fluid3D([4486,4867,5047,5143],0); -ELEMENTS[33582] = Fluid3D([13668,13009,13257,12721],0); -ELEMENTS[33583] = Fluid3D([12943,13511,13720,13485],0); -ELEMENTS[33584] = Fluid3D([5713,6386,5897,6140],0); -ELEMENTS[33585] = Fluid3D([6386,5897,6140,6641],0); -ELEMENTS[33586] = Fluid3D([16100,15841,16380,16019],0); -ELEMENTS[33587] = Fluid3D([13085,14093,13585,13758],0); -ELEMENTS[33588] = Fluid3D([13323,13178,12589,13048],0); -ELEMENTS[33589] = Fluid3D([13178,12589,13048,12726],0); -ELEMENTS[33590] = Fluid3D([12589,13323,13048,13303],0); -ELEMENTS[33591] = Fluid3D([7589,7147,7707,8202],0); -ELEMENTS[33592] = Fluid3D([5238,5838,5304,5438],0); -ELEMENTS[33593] = Fluid3D([9552,9098,10043,9175],0); -ELEMENTS[33594] = Fluid3D([4414,4443,4106,4035],0); -ELEMENTS[33595] = Fluid3D([4106,4414,4035,4204],0); -ELEMENTS[33596] = Fluid3D([9079,9191,8505,8429],0); -ELEMENTS[33597] = Fluid3D([14631,14529,13749,14508],0); -ELEMENTS[33598] = Fluid3D([14631,14529,14508,15239],0); -ELEMENTS[33599] = Fluid3D([13749,14631,14508,13952],0); -ELEMENTS[33600] = Fluid3D([14529,13749,14508,14153],0); -ELEMENTS[33601] = Fluid3D([13749,14508,14153,13750],0); -ELEMENTS[33602] = Fluid3D([14508,14153,13750,14577],0); -ELEMENTS[33603] = Fluid3D([14153,13750,14577,14066],0); -ELEMENTS[33604] = Fluid3D([14153,13750,14066,13392],0); -ELEMENTS[33605] = Fluid3D([14066,14153,13392,14529],0); -ELEMENTS[33606] = Fluid3D([14153,13750,13392,13749],0); -ELEMENTS[33607] = Fluid3D([13392,14153,13749,14529],0); -ELEMENTS[33608] = Fluid3D([14577,14153,14066,15030],0); -ELEMENTS[33609] = Fluid3D([14508,14153,14577,15030],0); -ELEMENTS[33610] = Fluid3D([14508,14529,14153,15030],0); -ELEMENTS[33611] = Fluid3D([16368,16822,16591,16147],0); -ELEMENTS[33612] = Fluid3D([13319,13464,12881,13954],0); -ELEMENTS[33613] = Fluid3D([11797,11450,12257,11671],0); -ELEMENTS[33614] = Fluid3D([4103,3907,3989,3745],0); -ELEMENTS[33615] = Fluid3D([13140,12442,13153,13484],0); -ELEMENTS[33616] = Fluid3D([3848,4218,4306,4029],0); -ELEMENTS[33617] = Fluid3D([9471,9910,10218,9045],0); -ELEMENTS[33618] = Fluid3D([14447,13941,14505,14691],0); -ELEMENTS[33619] = Fluid3D([12226,12555,12704,13085],0); -ELEMENTS[33620] = Fluid3D([16683,16622,17080,16926],0); -ELEMENTS[33621] = Fluid3D([16622,17080,16926,17045],0); -ELEMENTS[33622] = Fluid3D([16683,16622,16926,16475],0); -ELEMENTS[33623] = Fluid3D([16622,16926,16475,17045],0); -ELEMENTS[33624] = Fluid3D([17080,16683,16926,16972],0); -ELEMENTS[33625] = Fluid3D([4491,5108,4542,4490],0); -ELEMENTS[33626] = Fluid3D([9972,9633,9201,9361],0); -ELEMENTS[33627] = Fluid3D([16696,16245,16325,16149],0); -ELEMENTS[33628] = Fluid3D([6842,7073,6736,7666],0); -ELEMENTS[33629] = Fluid3D([9644,8772,9585,9608],0); -ELEMENTS[33630] = Fluid3D([5748,6050,6000,6541],0); -ELEMENTS[33631] = Fluid3D([3057,2943,2740,2924],0); -ELEMENTS[33632] = Fluid3D([16255,16171,15704,15737],0); -ELEMENTS[33633] = Fluid3D([16171,15704,15737,15715],0); -ELEMENTS[33634] = Fluid3D([7911,7279,7154,7297],0); -ELEMENTS[33635] = Fluid3D([12540,13382,12998,13249],0); -ELEMENTS[33636] = Fluid3D([10191,10886,10037,9618],0); -ELEMENTS[33637] = Fluid3D([17323,17547,17550,17756],0); -ELEMENTS[33638] = Fluid3D([12616,12483,11768,12152],0); -ELEMENTS[33639] = Fluid3D([3190,3060,3088,2956],0); -ELEMENTS[33640] = Fluid3D([8225,8779,8615,7647],0); -ELEMENTS[33641] = Fluid3D([9745,8766,9046,9253],0); -ELEMENTS[33642] = Fluid3D([8766,9046,9253,8831],0); -ELEMENTS[33643] = Fluid3D([9253,8766,8831,8952],0); -ELEMENTS[33644] = Fluid3D([9253,8766,8952,10073],0); -ELEMENTS[33645] = Fluid3D([8831,9253,8952,9055],0); -ELEMENTS[33646] = Fluid3D([9253,8952,9055,10073],0); -ELEMENTS[33647] = Fluid3D([8831,9253,9055,10073],0); -ELEMENTS[33648] = Fluid3D([9253,8766,10073,9745],0); -ELEMENTS[33649] = Fluid3D([8831,9253,10073,9514],0); -ELEMENTS[33650] = Fluid3D([8831,9253,9514,9221],0); -ELEMENTS[33651] = Fluid3D([8766,8831,8952,8658],0); -ELEMENTS[33652] = Fluid3D([8952,8766,8658,9225],0); -ELEMENTS[33653] = Fluid3D([8658,8952,9225,9565],0); -ELEMENTS[33654] = Fluid3D([8658,8952,9565,9055],0); -ELEMENTS[33655] = Fluid3D([8658,8952,9055,8831],0); -ELEMENTS[33656] = Fluid3D([8952,9565,9055,10073],0); -ELEMENTS[33657] = Fluid3D([9565,8658,9055,9219],0); -ELEMENTS[33658] = Fluid3D([9055,9565,9219,10096],0); -ELEMENTS[33659] = Fluid3D([9565,8658,9219,9799],0); -ELEMENTS[33660] = Fluid3D([9219,9565,9799,10146],0); -ELEMENTS[33661] = Fluid3D([9219,9565,10146,10096],0); -ELEMENTS[33662] = Fluid3D([8658,9055,9219,8409],0); -ELEMENTS[33663] = Fluid3D([8952,8766,9225,10073],0); -ELEMENTS[33664] = Fluid3D([9565,9799,10146,10428],0); -ELEMENTS[33665] = Fluid3D([9565,9799,10428,9225],0); -ELEMENTS[33666] = Fluid3D([9055,9219,8409,9153],0); -ELEMENTS[33667] = Fluid3D([9219,8658,8409,8633],0); -ELEMENTS[33668] = Fluid3D([8409,9219,8633,9153],0); -ELEMENTS[33669] = Fluid3D([8633,8409,9153,8273],0); -ELEMENTS[33670] = Fluid3D([8831,9253,9221,9046],0); -ELEMENTS[33671] = Fluid3D([9253,10073,9514,9745],0); -ELEMENTS[33672] = Fluid3D([9055,9219,9153,10096],0); -ELEMENTS[33673] = Fluid3D([8658,9055,8409,7716],0); -ELEMENTS[33674] = Fluid3D([9253,9221,9046,9745],0); -ELEMENTS[33675] = Fluid3D([9799,10146,10428,10422],0); -ELEMENTS[33676] = Fluid3D([10428,9799,10422,9225],0); -ELEMENTS[33677] = Fluid3D([9565,10146,10096,10245],0); -ELEMENTS[33678] = Fluid3D([10146,10096,10245,11056],0); -ELEMENTS[33679] = Fluid3D([10146,10096,11056,10810],0); -ELEMENTS[33680] = Fluid3D([10096,10245,11056,10937],0); -ELEMENTS[33681] = Fluid3D([11056,10146,10810,11061],0); -ELEMENTS[33682] = Fluid3D([10810,11056,11061,11928],0); -ELEMENTS[33683] = Fluid3D([10146,10096,10810,9885],0); -ELEMENTS[33684] = Fluid3D([11056,10096,10937,10810],0); -ELEMENTS[33685] = Fluid3D([10937,11056,10810,12000],0); -ELEMENTS[33686] = Fluid3D([10245,10146,11056,10428],0); -ELEMENTS[33687] = Fluid3D([10146,9565,10428,10245],0); -ELEMENTS[33688] = Fluid3D([10146,9219,10096,9885],0); -ELEMENTS[33689] = Fluid3D([8952,9225,9565,10073],0); -ELEMENTS[33690] = Fluid3D([8633,8409,8273,8070],0); -ELEMENTS[33691] = Fluid3D([8633,8409,8070,7716],0); -ELEMENTS[33692] = Fluid3D([8409,8273,8070,7716],0); -ELEMENTS[33693] = Fluid3D([8409,8273,7716,9055],0); -ELEMENTS[33694] = Fluid3D([10146,10810,11061,10765],0); -ELEMENTS[33695] = Fluid3D([9565,8658,9799,9225],0); -ELEMENTS[33696] = Fluid3D([8633,8409,7716,8331],0); -ELEMENTS[33697] = Fluid3D([8633,8409,8331,8658],0); -ELEMENTS[33698] = Fluid3D([11056,10146,11061,10428],0); -ELEMENTS[33699] = Fluid3D([10146,11061,10428,10422],0); -ELEMENTS[33700] = Fluid3D([11061,10428,10422,11295],0); -ELEMENTS[33701] = Fluid3D([11061,10428,11295,11056],0); -ELEMENTS[33702] = Fluid3D([9253,9514,9221,9745],0); -ELEMENTS[33703] = Fluid3D([9799,10422,9225,9421],0); -ELEMENTS[33704] = Fluid3D([10422,11061,11295,11160],0); -ELEMENTS[33705] = Fluid3D([11061,11295,11160,11808],0); -ELEMENTS[33706] = Fluid3D([11061,11295,11808,11592],0); -ELEMENTS[33707] = Fluid3D([11061,11295,11592,11056],0); -ELEMENTS[33708] = Fluid3D([11295,11808,11592,12583],0); -ELEMENTS[33709] = Fluid3D([11808,11061,11592,11928],0); -ELEMENTS[33710] = Fluid3D([11592,11808,11928,12583],0); -ELEMENTS[33711] = Fluid3D([11808,11061,11928,10765],0); -ELEMENTS[33712] = Fluid3D([11061,11592,11928,11056],0); -ELEMENTS[33713] = Fluid3D([11295,11160,11808,11889],0); -ELEMENTS[33714] = Fluid3D([11808,11295,11889,12583],0); -ELEMENTS[33715] = Fluid3D([11928,11592,12583,12000],0); -ELEMENTS[33716] = Fluid3D([11160,11061,11808,10765],0); -ELEMENTS[33717] = Fluid3D([11592,12583,12000,11484],0); -ELEMENTS[33718] = Fluid3D([11592,12583,11484,11694],0); -ELEMENTS[33719] = Fluid3D([11484,11592,11694,11056],0); -ELEMENTS[33720] = Fluid3D([11484,11592,11056,12000],0); -ELEMENTS[33721] = Fluid3D([11295,11160,11889,11770],0); -ELEMENTS[33722] = Fluid3D([11889,11295,11770,11694],0); -ELEMENTS[33723] = Fluid3D([11889,11295,11694,12583],0); -ELEMENTS[33724] = Fluid3D([11770,11889,11694,12213],0); -ELEMENTS[33725] = Fluid3D([11295,11770,11694,10428],0); -ELEMENTS[33726] = Fluid3D([11770,11889,12213,12985],0); -ELEMENTS[33727] = Fluid3D([11889,11694,12213,12454],0); -ELEMENTS[33728] = Fluid3D([12213,11889,12454,12985],0); -ELEMENTS[33729] = Fluid3D([12454,12213,12985,11816],0); -ELEMENTS[33730] = Fluid3D([11694,11770,12213,11816],0); -ELEMENTS[33731] = Fluid3D([11694,11295,10428,11056],0); -ELEMENTS[33732] = Fluid3D([11889,11694,12454,12583],0); -ELEMENTS[33733] = Fluid3D([12454,12213,11816,11694],0); -ELEMENTS[33734] = Fluid3D([12213,12985,11816,12323],0); -ELEMENTS[33735] = Fluid3D([12213,11770,12985,12323],0); -ELEMENTS[33736] = Fluid3D([11889,12454,12985,12544],0); -ELEMENTS[33737] = Fluid3D([11160,11889,11770,12544],0); -ELEMENTS[33738] = Fluid3D([11770,11889,12985,12535],0); -ELEMENTS[33739] = Fluid3D([11770,11889,12535,12544],0); -ELEMENTS[33740] = Fluid3D([11770,12213,11816,12323],0); -ELEMENTS[33741] = Fluid3D([11592,11928,11056,12000],0); -ELEMENTS[33742] = Fluid3D([8409,9055,9153,8273],0); -ELEMENTS[33743] = Fluid3D([9219,8633,9153,9885],0); -ELEMENTS[33744] = Fluid3D([10428,10422,11295,10676],0); -ELEMENTS[33745] = Fluid3D([9799,9219,10146,9885],0); -ELEMENTS[33746] = Fluid3D([10428,10422,10676,9225],0); -ELEMENTS[33747] = Fluid3D([10810,10146,9885,10765],0); -ELEMENTS[33748] = Fluid3D([10810,11061,10765,11928],0); -ELEMENTS[33749] = Fluid3D([8409,8658,7716,8331],0); -ELEMENTS[33750] = Fluid3D([3939,4048,4285,3831],0); -ELEMENTS[33751] = Fluid3D([4946,5378,5249,4819],0); -ELEMENTS[33752] = Fluid3D([5249,4946,4819,4606],0); -ELEMENTS[33753] = Fluid3D([4946,5378,4819,4941],0); -ELEMENTS[33754] = Fluid3D([4946,5378,4941,5136],0); -ELEMENTS[33755] = Fluid3D([4819,4946,4941,4413],0); -ELEMENTS[33756] = Fluid3D([4941,4819,4413,4837],0); -ELEMENTS[33757] = Fluid3D([4819,4413,4837,5131],0); -ELEMENTS[33758] = Fluid3D([4941,4819,4837,5378],0); -ELEMENTS[33759] = Fluid3D([5378,5249,4819,5131],0); -ELEMENTS[33760] = Fluid3D([5595,5458,5674,5090],0); -ELEMENTS[33761] = Fluid3D([5595,5458,5090,5111],0); -ELEMENTS[33762] = Fluid3D([5674,5595,5090,5419],0); -ELEMENTS[33763] = Fluid3D([5674,5595,5419,6150],0); -ELEMENTS[33764] = Fluid3D([5595,5090,5419,5225],0); -ELEMENTS[33765] = Fluid3D([5458,5090,5111,4829],0); -ELEMENTS[33766] = Fluid3D([5458,5090,4829,5335],0); -ELEMENTS[33767] = Fluid3D([5090,5111,4829,4661],0); -ELEMENTS[33768] = Fluid3D([5111,4829,4661,5016],0); -ELEMENTS[33769] = Fluid3D([4661,5111,5016,5212],0); -ELEMENTS[33770] = Fluid3D([4829,4661,5016,4651],0); -ELEMENTS[33771] = Fluid3D([4661,5111,5212,4889],0); -ELEMENTS[33772] = Fluid3D([5111,5212,4889,5595],0); -ELEMENTS[33773] = Fluid3D([4661,5111,4889,5090],0); -ELEMENTS[33774] = Fluid3D([5111,5016,5212,5458],0); -ELEMENTS[33775] = Fluid3D([5016,4829,4651,5079],0); -ELEMENTS[33776] = Fluid3D([4829,4661,4651,4173],0); -ELEMENTS[33777] = Fluid3D([5111,4829,5016,5458],0); -ELEMENTS[33778] = Fluid3D([5090,5595,5111,4889],0); -ELEMENTS[33779] = Fluid3D([5595,5458,5111,5212],0); -ELEMENTS[33780] = Fluid3D([5090,5674,5419,5047],0); -ELEMENTS[33781] = Fluid3D([5419,5090,5047,4864],0); -ELEMENTS[33782] = Fluid3D([5090,5047,4864,4485],0); -ELEMENTS[33783] = Fluid3D([5047,5419,4864,5143],0); -ELEMENTS[33784] = Fluid3D([5090,5674,5047,4731],0); -ELEMENTS[33785] = Fluid3D([5419,5090,4864,5225],0); -ELEMENTS[33786] = Fluid3D([4864,5419,5225,5077],0); -ELEMENTS[33787] = Fluid3D([5674,5419,5047,5479],0); -ELEMENTS[33788] = Fluid3D([5458,5674,5090,5335],0); -ELEMENTS[33789] = Fluid3D([7771,8112,7780,7234],0); -ELEMENTS[33790] = Fluid3D([12809,12681,12014,12801],0); -ELEMENTS[33791] = Fluid3D([12681,12014,12801,12089],0); -ELEMENTS[33792] = Fluid3D([12801,12681,12089,13103],0); -ELEMENTS[33793] = Fluid3D([12089,12801,13103,13272],0); -ELEMENTS[33794] = Fluid3D([15217,15559,15305,15906],0); -ELEMENTS[33795] = Fluid3D([4449,4863,4983,4673],0); -ELEMENTS[33796] = Fluid3D([10233,9747,9231,9602],0); -ELEMENTS[33797] = Fluid3D([9747,9231,9602,8822],0); -ELEMENTS[33798] = Fluid3D([9602,9747,8822,9583],0); -ELEMENTS[33799] = Fluid3D([10233,9747,9602,10882],0); -ELEMENTS[33800] = Fluid3D([9602,9747,9583,10652],0); -ELEMENTS[33801] = Fluid3D([15294,15403,15015,14728],0); -ELEMENTS[33802] = Fluid3D([15015,15294,14728,14656],0); -ELEMENTS[33803] = Fluid3D([15294,14728,14656,14594],0); -ELEMENTS[33804] = Fluid3D([15294,15403,14728,15177],0); -ELEMENTS[33805] = Fluid3D([15294,15403,15177,15721],0); -ELEMENTS[33806] = Fluid3D([15177,15294,15721,15566],0); -ELEMENTS[33807] = Fluid3D([15721,15177,15566,15380],0); -ELEMENTS[33808] = Fluid3D([15721,15177,15380,15398],0); -ELEMENTS[33809] = Fluid3D([15721,15177,15398,15403],0); -ELEMENTS[33810] = Fluid3D([14728,15294,15177,14594],0); -ELEMENTS[33811] = Fluid3D([15403,15015,14728,14548],0); -ELEMENTS[33812] = Fluid3D([15015,14728,14548,14656],0); -ELEMENTS[33813] = Fluid3D([15403,14728,15177,14930],0); -ELEMENTS[33814] = Fluid3D([14728,15177,14930,14416],0); -ELEMENTS[33815] = Fluid3D([14930,14728,14416,14219],0); -ELEMENTS[33816] = Fluid3D([15403,14728,14930,14548],0); -ELEMENTS[33817] = Fluid3D([15177,15403,14930,15398],0); -ELEMENTS[33818] = Fluid3D([14930,15177,15398,14416],0); -ELEMENTS[33819] = Fluid3D([11292,11182,11900,11605],0); -ELEMENTS[33820] = Fluid3D([5277,5810,5828,5124],0); -ELEMENTS[33821] = Fluid3D([6836,6463,6608,5758],0); -ELEMENTS[33822] = Fluid3D([15706,15733,15300,15169],0); -ELEMENTS[33823] = Fluid3D([16247,16614,16552,16723],0); -ELEMENTS[33824] = Fluid3D([15147,15792,15674,15558],0); -ELEMENTS[33825] = Fluid3D([3698,4102,4125,3967],0); -ELEMENTS[33826] = Fluid3D([4125,3698,3967,3770],0); -ELEMENTS[33827] = Fluid3D([3698,3967,3770,3504],0); -ELEMENTS[33828] = Fluid3D([3967,3770,3504,3895],0); -ELEMENTS[33829] = Fluid3D([3698,3967,3504,3595],0); -ELEMENTS[33830] = Fluid3D([3698,4102,3967,3595],0); -ELEMENTS[33831] = Fluid3D([4125,3698,3770,3738],0); -ELEMENTS[33832] = Fluid3D([3967,4125,3770,4372],0); -ELEMENTS[33833] = Fluid3D([3770,3698,3504,3308],0); -ELEMENTS[33834] = Fluid3D([4102,4125,3967,4479],0); -ELEMENTS[33835] = Fluid3D([4102,4125,4479,4480],0); -ELEMENTS[33836] = Fluid3D([4125,3967,4479,4372],0); -ELEMENTS[33837] = Fluid3D([3967,4102,4479,4077],0); -ELEMENTS[33838] = Fluid3D([9020,9415,9701,8911],0); -ELEMENTS[33839] = Fluid3D([9701,9020,8911,9259],0); -ELEMENTS[33840] = Fluid3D([9415,9701,8911,9518],0); -ELEMENTS[33841] = Fluid3D([9701,8911,9518,8722],0); -ELEMENTS[33842] = Fluid3D([9415,9701,9518,10719],0); -ELEMENTS[33843] = Fluid3D([8911,9415,9518,8912],0); -ELEMENTS[33844] = Fluid3D([9518,8911,8912,8722],0); -ELEMENTS[33845] = Fluid3D([9020,9415,8911,8517],0); -ELEMENTS[33846] = Fluid3D([11520,12284,12394,12062],0); -ELEMENTS[33847] = Fluid3D([8586,8470,7723,7929],0); -ELEMENTS[33848] = Fluid3D([12965,13094,12463,12300],0); -ELEMENTS[33849] = Fluid3D([18350,18231,18160,18340],0); -ELEMENTS[33850] = Fluid3D([5192,5581,5632,5979],0); -ELEMENTS[33851] = Fluid3D([12779,12770,13399,12149],0); -ELEMENTS[33852] = Fluid3D([16916,16833,16424,16687],0); -ELEMENTS[33853] = Fluid3D([9093,8219,8365,8852],0); -ELEMENTS[33854] = Fluid3D([15415,14965,14701,15234],0); -ELEMENTS[33855] = Fluid3D([15045,15758,15685,15628],0); -ELEMENTS[33856] = Fluid3D([13149,13925,13334,13321],0); -ELEMENTS[33857] = Fluid3D([2568,2680,2846,2425],0); -ELEMENTS[33858] = Fluid3D([2793,3022,3019,2718],0); -ELEMENTS[33859] = Fluid3D([3022,3019,2718,2997],0); -ELEMENTS[33860] = Fluid3D([2793,3022,2718,2770],0); -ELEMENTS[33861] = Fluid3D([3019,2793,2718,2725],0); -ELEMENTS[33862] = Fluid3D([2718,3019,2725,3077],0); -ELEMENTS[33863] = Fluid3D([2718,3019,3077,2997],0); -ELEMENTS[33864] = Fluid3D([2793,2718,2725,2493],0); -ELEMENTS[33865] = Fluid3D([2793,2718,2493,2770],0); -ELEMENTS[33866] = Fluid3D([2725,2793,2493,2401],0); -ELEMENTS[33867] = Fluid3D([2493,2725,2401,2497],0); -ELEMENTS[33868] = Fluid3D([3019,2793,2725,3026],0); -ELEMENTS[33869] = Fluid3D([2725,3019,3026,3073],0); -ELEMENTS[33870] = Fluid3D([3019,3026,3073,3392],0); -ELEMENTS[33871] = Fluid3D([2718,2725,2493,2497],0); -ELEMENTS[33872] = Fluid3D([17046,17014,16667,17163],0); -ELEMENTS[33873] = Fluid3D([11710,10724,10993,11483],0); -ELEMENTS[33874] = Fluid3D([7109,7254,7942,7780],0); -ELEMENTS[33875] = Fluid3D([17454,17280,17120,17576],0); -ELEMENTS[33876] = Fluid3D([14652,14934,15370,14363],0); -ELEMENTS[33877] = Fluid3D([10051,9212,9216,8925],0); -ELEMENTS[33878] = Fluid3D([7842,7472,7829,6953],0); -ELEMENTS[33879] = Fluid3D([13433,13773,13036,12767],0); -ELEMENTS[33880] = Fluid3D([13036,13433,12767,12763],0); -ELEMENTS[33881] = Fluid3D([7121,6952,7856,7919],0); -ELEMENTS[33882] = Fluid3D([10426,10050,10912,11058],0); -ELEMENTS[33883] = Fluid3D([14478,14375,15081,15268],0); -ELEMENTS[33884] = Fluid3D([6602,6692,7351,6462],0); -ELEMENTS[33885] = Fluid3D([16760,16728,16969,17199],0); -ELEMENTS[33886] = Fluid3D([8308,8843,8441,9135],0); -ELEMENTS[33887] = Fluid3D([14992,14371,14983,14296],0); -ELEMENTS[33888] = Fluid3D([16096,16309,16500,15927],0); -ELEMENTS[33889] = Fluid3D([15165,14500,14856,15567],0); -ELEMENTS[33890] = Fluid3D([13205,13100,12335,13252],0); -ELEMENTS[33891] = Fluid3D([5560,6004,5802,5616],0); -ELEMENTS[33892] = Fluid3D([2404,2311,2152,2326],0); -ELEMENTS[33893] = Fluid3D([8606,8054,8494,7788],0); -ELEMENTS[33894] = Fluid3D([8606,8054,7788,7540],0); -ELEMENTS[33895] = Fluid3D([8054,8494,7788,7416],0); -ELEMENTS[33896] = Fluid3D([8494,8606,7788,8331],0); -ELEMENTS[33897] = Fluid3D([8606,7788,8331,7540],0); -ELEMENTS[33898] = Fluid3D([7788,8331,7540,6902],0); -ELEMENTS[33899] = Fluid3D([9142,8589,9481,8750],0); -ELEMENTS[33900] = Fluid3D([15635,15478,15353,16251],0); -ELEMENTS[33901] = Fluid3D([15727,15228,15835,15692],0); -ELEMENTS[33902] = Fluid3D([17484,17572,17715,17915],0); -ELEMENTS[33903] = Fluid3D([2844,3185,3098,3053],0); -ELEMENTS[33904] = Fluid3D([6299,5728,5778,6008],0); -ELEMENTS[33905] = Fluid3D([13812,13253,13245,14009],0); -ELEMENTS[33906] = Fluid3D([17590,17697,17309,17575],0); -ELEMENTS[33907] = Fluid3D([6768,7510,7030,7096],0); -ELEMENTS[33908] = Fluid3D([7510,7030,7096,7850],0); -ELEMENTS[33909] = Fluid3D([4740,4852,5022,4692],0); -ELEMENTS[33910] = Fluid3D([4852,5022,4692,5476],0); -ELEMENTS[33911] = Fluid3D([4692,4852,5476,5148],0); -ELEMENTS[33912] = Fluid3D([4692,4852,5148,4508],0); -ELEMENTS[33913] = Fluid3D([4852,5476,5148,5391],0); -ELEMENTS[33914] = Fluid3D([5148,4852,5391,4801],0); -ELEMENTS[33915] = Fluid3D([4852,5391,4801,4668],0); -ELEMENTS[33916] = Fluid3D([5148,4852,4801,4508],0); -ELEMENTS[33917] = Fluid3D([4852,4801,4508,4668],0); -ELEMENTS[33918] = Fluid3D([4692,4852,4508,4447],0); -ELEMENTS[33919] = Fluid3D([4692,4852,4447,4740],0); -ELEMENTS[33920] = Fluid3D([4852,4447,4740,4409],0); -ELEMENTS[33921] = Fluid3D([4447,4740,4409,4446],0); -ELEMENTS[33922] = Fluid3D([4409,4447,4446,4061],0); -ELEMENTS[33923] = Fluid3D([4409,4447,4061,4508],0); -ELEMENTS[33924] = Fluid3D([4446,4409,4061,4239],0); -ELEMENTS[33925] = Fluid3D([4409,4061,4239,3925],0); -ELEMENTS[33926] = Fluid3D([4852,4447,4409,4508],0); -ELEMENTS[33927] = Fluid3D([4061,4239,3925,3760],0); -ELEMENTS[33928] = Fluid3D([4061,4239,3760,4446],0); -ELEMENTS[33929] = Fluid3D([4740,4409,4446,4771],0); -ELEMENTS[33930] = Fluid3D([4409,4446,4771,4521],0); -ELEMENTS[33931] = Fluid3D([4446,4740,4771,4708],0); -ELEMENTS[33932] = Fluid3D([4771,4446,4708,4369],0); -ELEMENTS[33933] = Fluid3D([4446,4771,4521,4369],0); -ELEMENTS[33934] = Fluid3D([3925,4061,3760,3555],0); -ELEMENTS[33935] = Fluid3D([4447,4740,4446,4135],0); -ELEMENTS[33936] = Fluid3D([4447,4740,4135,4692],0); -ELEMENTS[33937] = Fluid3D([4446,4447,4135,4061],0); -ELEMENTS[33938] = Fluid3D([4447,4135,4061,4508],0); -ELEMENTS[33939] = Fluid3D([4135,4446,4061,4217],0); -ELEMENTS[33940] = Fluid3D([4135,4447,4692,4508],0); -ELEMENTS[33941] = Fluid3D([4446,4409,4239,4521],0); -ELEMENTS[33942] = Fluid3D([4409,4239,4521,4668],0); -ELEMENTS[33943] = Fluid3D([4409,4239,4668,4463],0); -ELEMENTS[33944] = Fluid3D([4521,4409,4668,4771],0); -ELEMENTS[33945] = Fluid3D([4409,4668,4771,4740],0); -ELEMENTS[33946] = Fluid3D([4409,4668,4740,4852],0); -ELEMENTS[33947] = Fluid3D([4239,4521,4668,4683],0); -ELEMENTS[33948] = Fluid3D([4409,4668,4852,4508],0); -ELEMENTS[33949] = Fluid3D([4239,4521,4683,4129],0); -ELEMENTS[33950] = Fluid3D([4668,4239,4683,4129],0); -ELEMENTS[33951] = Fluid3D([9086,9551,9180,8616],0); -ELEMENTS[33952] = Fluid3D([12805,11856,12178,12182],0); -ELEMENTS[33953] = Fluid3D([10425,9999,9696,9440],0); -ELEMENTS[33954] = Fluid3D([10425,9999,9440,10546],0); -ELEMENTS[33955] = Fluid3D([9696,10425,9440,9887],0); -ELEMENTS[33956] = Fluid3D([9999,9696,9440,8622],0); -ELEMENTS[33957] = Fluid3D([13252,13431,12639,13205],0); -ELEMENTS[33958] = Fluid3D([13431,12639,13205,12763],0); -ELEMENTS[33959] = Fluid3D([7667,8455,7972,8492],0); -ELEMENTS[33960] = Fluid3D([5879,6438,6528,6346],0); -ELEMENTS[33961] = Fluid3D([6898,7641,7081,7135],0); -ELEMENTS[33962] = Fluid3D([18294,18038,18207,18063],0); -ELEMENTS[33963] = Fluid3D([18038,18207,18063,18041],0); -ELEMENTS[33964] = Fluid3D([18207,18063,18041,18360],0); -ELEMENTS[33965] = Fluid3D([3507,3596,3890,3860],0); -ELEMENTS[33966] = Fluid3D([3507,3596,3860,3378],0); -ELEMENTS[33967] = Fluid3D([3890,3507,3860,3730],0); -ELEMENTS[33968] = Fluid3D([3507,3860,3730,3431],0); -ELEMENTS[33969] = Fluid3D([3596,3890,3860,4217],0); -ELEMENTS[33970] = Fluid3D([3890,3860,4217,4269],0); -ELEMENTS[33971] = Fluid3D([3860,4217,4269,4003],0); -ELEMENTS[33972] = Fluid3D([3860,4217,4003,4014],0); -ELEMENTS[33973] = Fluid3D([4269,3860,4003,3916],0); -ELEMENTS[33974] = Fluid3D([3860,4217,4014,3596],0); -ELEMENTS[33975] = Fluid3D([4003,3860,4014,3629],0); -ELEMENTS[33976] = Fluid3D([9995,9443,9191,10022],0); -ELEMENTS[33977] = Fluid3D([9191,9995,10022,10185],0); -ELEMENTS[33978] = Fluid3D([9995,10022,10185,10726],0); -ELEMENTS[33979] = Fluid3D([10022,10185,10726,10503],0); -ELEMENTS[33980] = Fluid3D([10726,10022,10503,10550],0); -ELEMENTS[33981] = Fluid3D([10022,10503,10550,9567],0); -ELEMENTS[33982] = Fluid3D([10726,10022,10550,10549],0); -ELEMENTS[33983] = Fluid3D([9995,10022,10726,10549],0); -ELEMENTS[33984] = Fluid3D([10503,10726,10550,11701],0); -ELEMENTS[33985] = Fluid3D([9995,9443,10022,10549],0); -ELEMENTS[33986] = Fluid3D([9443,9191,10022,9255],0); -ELEMENTS[33987] = Fluid3D([9191,10022,9255,10185],0); -ELEMENTS[33988] = Fluid3D([9191,9995,10185,9420],0); -ELEMENTS[33989] = Fluid3D([4720,4893,4745,4281],0); -ELEMENTS[33990] = Fluid3D([13641,13080,12878,13753],0); -ELEMENTS[33991] = Fluid3D([6336,6838,7153,7090],0); -ELEMENTS[33992] = Fluid3D([6838,7153,7090,8228],0); -ELEMENTS[33993] = Fluid3D([6336,6838,7090,5974],0); -ELEMENTS[33994] = Fluid3D([14604,14996,15329,15039],0); -ELEMENTS[33995] = Fluid3D([6031,6048,6636,6600],0); -ELEMENTS[33996] = Fluid3D([6636,6031,6600,6662],0); -ELEMENTS[33997] = Fluid3D([6031,6600,6662,6166],0); -ELEMENTS[33998] = Fluid3D([6600,6636,6662,7777],0); -ELEMENTS[33999] = Fluid3D([6031,6048,6600,6130],0); -ELEMENTS[34000] = Fluid3D([6600,6031,6130,5532],0); -ELEMENTS[34001] = Fluid3D([6636,6031,6662,6306],0); -ELEMENTS[34002] = Fluid3D([6048,6636,6600,6773],0); -ELEMENTS[34003] = Fluid3D([6636,6600,6773,7597],0); -ELEMENTS[34004] = Fluid3D([6048,6636,6773,6218],0); -ELEMENTS[34005] = Fluid3D([13860,13222,12981,13399],0); -ELEMENTS[34006] = Fluid3D([11297,11276,11332,12056],0); -ELEMENTS[34007] = Fluid3D([11332,11297,12056,11920],0); -ELEMENTS[34008] = Fluid3D([11297,12056,11920,12061],0); -ELEMENTS[34009] = Fluid3D([11297,11276,12056,11950],0); -ELEMENTS[34010] = Fluid3D([11332,11297,11920,11713],0); -ELEMENTS[34011] = Fluid3D([12056,11332,11920,12292],0); -ELEMENTS[34012] = Fluid3D([11276,11332,12056,11514],0); -ELEMENTS[34013] = Fluid3D([5713,6157,6180,5880],0); -ELEMENTS[34014] = Fluid3D([11434,11399,11366,10425],0); -ELEMENTS[34015] = Fluid3D([13755,13733,13049,12976],0); -ELEMENTS[34016] = Fluid3D([6066,5741,5752,6372],0); -ELEMENTS[34017] = Fluid3D([10437,11021,11446,10619],0); -ELEMENTS[34018] = Fluid3D([4612,4175,4727,4441],0); -ELEMENTS[34019] = Fluid3D([15240,14599,15268,15144],0); -ELEMENTS[34020] = Fluid3D([12088,12455,11978,12706],0); -ELEMENTS[34021] = Fluid3D([12455,11978,12706,12690],0); -ELEMENTS[34022] = Fluid3D([11978,12088,12706,12554],0); -ELEMENTS[34023] = Fluid3D([13214,13563,13035,14004],0); -ELEMENTS[34024] = Fluid3D([13214,13563,14004,14092],0); -ELEMENTS[34025] = Fluid3D([14504,15269,14868,14564],0); -ELEMENTS[34026] = Fluid3D([10680,10596,9857,10807],0); -ELEMENTS[34027] = Fluid3D([9857,10680,10807,10117],0); -ELEMENTS[34028] = Fluid3D([10807,9857,10117,10109],0); -ELEMENTS[34029] = Fluid3D([10596,9857,10807,10109],0); -ELEMENTS[34030] = Fluid3D([10680,10596,10807,11591],0); -ELEMENTS[34031] = Fluid3D([14974,14787,14170,14132],0); -ELEMENTS[34032] = Fluid3D([9208,9415,8517,8414],0); -ELEMENTS[34033] = Fluid3D([17650,17401,17406,17748],0); -ELEMENTS[34034] = Fluid3D([17406,17650,17748,17752],0); -ELEMENTS[34035] = Fluid3D([17401,17406,17748,17543],0); -ELEMENTS[34036] = Fluid3D([17748,17401,17543,17876],0); -ELEMENTS[34037] = Fluid3D([17543,17748,17876,17832],0); -ELEMENTS[34038] = Fluid3D([17650,17401,17748,17876],0); -ELEMENTS[34039] = Fluid3D([10978,11874,11168,10357],0); -ELEMENTS[34040] = Fluid3D([8877,8612,8347,7979],0); -ELEMENTS[34041] = Fluid3D([4480,4807,4977,4450],0); -ELEMENTS[34042] = Fluid3D([2932,3147,3180,2721],0); -ELEMENTS[34043] = Fluid3D([16641,16898,17123,16750],0); -ELEMENTS[34044] = Fluid3D([16126,16333,15998,16617],0); -ELEMENTS[34045] = Fluid3D([4737,5172,5385,5133],0); -ELEMENTS[34046] = Fluid3D([4319,3926,4014,3680],0); -ELEMENTS[34047] = Fluid3D([2858,2841,2963,2572],0); -ELEMENTS[34048] = Fluid3D([15222,15470,15866,15728],0); -ELEMENTS[34049] = Fluid3D([11554,11956,11552,12239],0); -ELEMENTS[34050] = Fluid3D([11956,11552,12239,12633],0); -ELEMENTS[34051] = Fluid3D([11552,11554,12239,11232],0); -ELEMENTS[34052] = Fluid3D([5498,5786,6164,5460],0); -ELEMENTS[34053] = Fluid3D([16949,16977,16947,16513],0); -ELEMENTS[34054] = Fluid3D([12615,11848,11861,12237],0); -ELEMENTS[34055] = Fluid3D([10210,9714,9853,10806],0); -ELEMENTS[34056] = Fluid3D([9853,10210,10806,10555],0); -ELEMENTS[34057] = Fluid3D([10210,10806,10555,10621],0); -ELEMENTS[34058] = Fluid3D([10210,10806,10621,11481],0); -ELEMENTS[34059] = Fluid3D([3985,3864,4009,3492],0); -ELEMENTS[34060] = Fluid3D([12298,11893,12763,12527],0); -ELEMENTS[34061] = Fluid3D([7180,6659,7005,7618],0); -ELEMENTS[34062] = Fluid3D([13310,13944,14226,14032],0); -ELEMENTS[34063] = Fluid3D([4205,4406,4416,3962],0); -ELEMENTS[34064] = Fluid3D([10720,11403,10876,11895],0); -ELEMENTS[34065] = Fluid3D([13511,13180,13626,12633],0); -ELEMENTS[34066] = Fluid3D([9709,9366,8748,8591],0); -ELEMENTS[34067] = Fluid3D([3210,3413,3314,3015],0); -ELEMENTS[34068] = Fluid3D([14321,13816,13775,13637],0); -ELEMENTS[34069] = Fluid3D([12358,13178,12726,12589],0); -ELEMENTS[34070] = Fluid3D([6427,6488,7189,6449],0); -ELEMENTS[34071] = Fluid3D([5688,6270,5643,5949],0); -ELEMENTS[34072] = Fluid3D([6270,5643,5949,6375],0); -ELEMENTS[34073] = Fluid3D([5688,6270,5949,6457],0); -ELEMENTS[34074] = Fluid3D([5643,5688,5949,5175],0); -ELEMENTS[34075] = Fluid3D([5688,5949,5175,5909],0); -ELEMENTS[34076] = Fluid3D([5949,5643,5175,5393],0); -ELEMENTS[34077] = Fluid3D([5643,5688,5175,5238],0); -ELEMENTS[34078] = Fluid3D([7291,7803,7112,7921],0); -ELEMENTS[34079] = Fluid3D([7291,7803,7921,8342],0); -ELEMENTS[34080] = Fluid3D([7921,7291,8342,7815],0); -ELEMENTS[34081] = Fluid3D([8342,7921,7815,8635],0); -ELEMENTS[34082] = Fluid3D([7921,7291,7815,7420],0); -ELEMENTS[34083] = Fluid3D([10527,9821,10552,10638],0); -ELEMENTS[34084] = Fluid3D([4745,4337,4281,4025],0); -ELEMENTS[34085] = Fluid3D([13705,13509,13190,14361],0); -ELEMENTS[34086] = Fluid3D([13823,14607,13952,14612],0); -ELEMENTS[34087] = Fluid3D([17564,17638,17264,17590],0); -ELEMENTS[34088] = Fluid3D([17638,17264,17590,17354],0); -ELEMENTS[34089] = Fluid3D([15606,16146,15796,15954],0); -ELEMENTS[34090] = Fluid3D([10360,10777,10066,9824],0); -ELEMENTS[34091] = Fluid3D([10066,10360,9824,9446],0); -ELEMENTS[34092] = Fluid3D([10360,9824,9446,9734],0); -ELEMENTS[34093] = Fluid3D([10360,10777,9824,10745],0); -ELEMENTS[34094] = Fluid3D([10066,10360,9446,9642],0); -ELEMENTS[34095] = Fluid3D([9446,10066,9642,8865],0); -ELEMENTS[34096] = Fluid3D([10777,10066,9824,10414],0); -ELEMENTS[34097] = Fluid3D([9824,10066,9446,8865],0); -ELEMENTS[34098] = Fluid3D([11581,11690,11703,12641],0); -ELEMENTS[34099] = Fluid3D([12541,11729,11671,12257],0); -ELEMENTS[34100] = Fluid3D([11671,12541,12257,12887],0); -ELEMENTS[34101] = Fluid3D([12541,11729,12257,12190],0); -ELEMENTS[34102] = Fluid3D([11729,11671,12257,11450],0); -ELEMENTS[34103] = Fluid3D([10606,9774,9678,10070],0); -ELEMENTS[34104] = Fluid3D([9678,10606,10070,10459],0); -ELEMENTS[34105] = Fluid3D([12472,12500,11908,11709],0); -ELEMENTS[34106] = Fluid3D([13215,13370,13734,12706],0); -ELEMENTS[34107] = Fluid3D([16683,16658,16423,16889],0); -ELEMENTS[34108] = Fluid3D([16423,16683,16889,16155],0); -ELEMENTS[34109] = Fluid3D([6490,6014,6174,7113],0); -ELEMENTS[34110] = Fluid3D([12736,11767,12409,12027],0); -ELEMENTS[34111] = Fluid3D([10706,11721,11149,11367],0); -ELEMENTS[34112] = Fluid3D([11721,11149,11367,12348],0); -ELEMENTS[34113] = Fluid3D([10706,11721,11367,11162],0); -ELEMENTS[34114] = Fluid3D([11149,10706,11367,9896],0); -ELEMENTS[34115] = Fluid3D([12290,12112,11541,11320],0); -ELEMENTS[34116] = Fluid3D([14931,14709,14273,14797],0); -ELEMENTS[34117] = Fluid3D([14273,14931,14797,14619],0); -ELEMENTS[34118] = Fluid3D([14931,14797,14619,15264],0); -ELEMENTS[34119] = Fluid3D([14619,14931,15264,15070],0); -ELEMENTS[34120] = Fluid3D([14931,15264,15070,15920],0); -ELEMENTS[34121] = Fluid3D([14931,14797,15264,15613],0); -ELEMENTS[34122] = Fluid3D([15264,14931,15613,15920],0); -ELEMENTS[34123] = Fluid3D([9669,10242,9858,9223],0); -ELEMENTS[34124] = Fluid3D([15011,14743,14707,15632],0); -ELEMENTS[34125] = Fluid3D([4601,4480,4557,3988],0); -ELEMENTS[34126] = Fluid3D([3122,2947,2920,2671],0); -ELEMENTS[34127] = Fluid3D([17134,17363,17031,16860],0); -ELEMENTS[34128] = Fluid3D([9444,10525,10181,10288],0); -ELEMENTS[34129] = Fluid3D([8413,8021,7258,7860],0); -ELEMENTS[34130] = Fluid3D([10946,10993,10228,10028],0); -ELEMENTS[34131] = Fluid3D([10993,10228,10028,10087],0); -ELEMENTS[34132] = Fluid3D([10228,10946,10028,10294],0); -ELEMENTS[34133] = Fluid3D([10028,10228,10294,9934],0); -ELEMENTS[34134] = Fluid3D([10228,10294,9934,10452],0); -ELEMENTS[34135] = Fluid3D([10294,9934,10452,9804],0); -ELEMENTS[34136] = Fluid3D([10294,9934,9804,10028],0); -ELEMENTS[34137] = Fluid3D([9804,10294,10028,10946],0); -ELEMENTS[34138] = Fluid3D([10452,10294,9804,10946],0); -ELEMENTS[34139] = Fluid3D([10228,10946,10294,10452],0); -ELEMENTS[34140] = Fluid3D([17091,17053,17108,16624],0); -ELEMENTS[34141] = Fluid3D([13325,13251,14053,13632],0); -ELEMENTS[34142] = Fluid3D([12552,11762,12382,12737],0); -ELEMENTS[34143] = Fluid3D([4991,5045,4507,5144],0); -ELEMENTS[34144] = Fluid3D([8845,8779,8225,8090],0); -ELEMENTS[34145] = Fluid3D([12576,12678,12080,13302],0); -ELEMENTS[34146] = Fluid3D([5645,5170,5131,4837],0); -ELEMENTS[34147] = Fluid3D([13792,14152,14510,13892],0); -ELEMENTS[34148] = Fluid3D([14510,13792,13892,13825],0); -ELEMENTS[34149] = Fluid3D([13792,14152,13892,13271],0); -ELEMENTS[34150] = Fluid3D([14152,14510,13892,14389],0); -ELEMENTS[34151] = Fluid3D([13792,13892,13825,12736],0); -ELEMENTS[34152] = Fluid3D([13892,14152,14389,13765],0); -ELEMENTS[34153] = Fluid3D([14152,13892,13271,13765],0); -ELEMENTS[34154] = Fluid3D([14510,13792,13825,14640],0); -ELEMENTS[34155] = Fluid3D([3669,3875,3458,4087],0); -ELEMENTS[34156] = Fluid3D([7171,6792,7290,6723],0); -ELEMENTS[34157] = Fluid3D([8461,8607,9236,7908],0); -ELEMENTS[34158] = Fluid3D([12209,12572,11713,11920],0); -ELEMENTS[34159] = Fluid3D([12572,11713,11920,12061],0); -ELEMENTS[34160] = Fluid3D([12209,12572,11920,12608],0); -ELEMENTS[34161] = Fluid3D([11713,12209,11920,11162],0); -ELEMENTS[34162] = Fluid3D([12572,11920,12608,12056],0); -ELEMENTS[34163] = Fluid3D([11920,12209,12608,12292],0); -ELEMENTS[34164] = Fluid3D([11920,12608,12056,12292],0); -ELEMENTS[34165] = Fluid3D([11920,12572,12061,12056],0); -ELEMENTS[34166] = Fluid3D([12209,12572,12608,13185],0); -ELEMENTS[34167] = Fluid3D([14861,15196,15247,14487],0); -ELEMENTS[34168] = Fluid3D([15247,14861,14487,14430],0); -ELEMENTS[34169] = Fluid3D([8917,9001,8417,8314],0); -ELEMENTS[34170] = Fluid3D([11608,11456,11324,10243],0); -ELEMENTS[34171] = Fluid3D([16069,15517,15622,15942],0); -ELEMENTS[34172] = Fluid3D([16069,15517,15942,16297],0); -ELEMENTS[34173] = Fluid3D([15622,16069,15942,16465],0); -ELEMENTS[34174] = Fluid3D([15517,15622,15942,15473],0); -ELEMENTS[34175] = Fluid3D([13415,12576,13302,12678],0); -ELEMENTS[34176] = Fluid3D([7843,8742,7722,7280],0); -ELEMENTS[34177] = Fluid3D([10143,9689,10429,10826],0); -ELEMENTS[34178] = Fluid3D([16214,16208,16422,16691],0); -ELEMENTS[34179] = Fluid3D([15970,15567,15318,15852],0); -ELEMENTS[34180] = Fluid3D([16172,15792,16350,16164],0); -ELEMENTS[34181] = Fluid3D([3299,3534,3369,3659],0); -ELEMENTS[34182] = Fluid3D([4572,4765,4975,4557],0); -ELEMENTS[34183] = Fluid3D([4975,4572,4557,4965],0); -ELEMENTS[34184] = Fluid3D([11562,11878,11821,10791],0); -ELEMENTS[34185] = Fluid3D([9376,8957,8519,9407],0); -ELEMENTS[34186] = Fluid3D([13794,14495,13593,14178],0); -ELEMENTS[34187] = Fluid3D([17083,17220,17251,16926],0); -ELEMENTS[34188] = Fluid3D([17220,17251,16926,17080],0); -ELEMENTS[34189] = Fluid3D([9462,9311,9096,8497],0); -ELEMENTS[34190] = Fluid3D([3816,4017,3899,3515],0); -ELEMENTS[34191] = Fluid3D([13142,14024,13733,13851],0); -ELEMENTS[34192] = Fluid3D([17753,17832,18011,18021],0); -ELEMENTS[34193] = Fluid3D([17753,17832,18021,17740],0); -ELEMENTS[34194] = Fluid3D([17832,18021,17740,18087],0); -ELEMENTS[34195] = Fluid3D([17832,18021,18087,18011],0); -ELEMENTS[34196] = Fluid3D([18021,17740,18087,18072],0); -ELEMENTS[34197] = Fluid3D([18087,18021,18072,18290],0); -ELEMENTS[34198] = Fluid3D([18087,18021,18290,18307],0); -ELEMENTS[34199] = Fluid3D([18087,18021,18307,18011],0); -ELEMENTS[34200] = Fluid3D([10187,11037,10381,11203],0); -ELEMENTS[34201] = Fluid3D([16143,16320,16677,16290],0); -ELEMENTS[34202] = Fluid3D([16885,16469,16803,16332],0); -ELEMENTS[34203] = Fluid3D([16469,16803,16332,16218],0); -ELEMENTS[34204] = Fluid3D([16702,16922,17005,17327],0); -ELEMENTS[34205] = Fluid3D([15299,15279,15480,16042],0); -ELEMENTS[34206] = Fluid3D([3764,4193,4203,3874],0); -ELEMENTS[34207] = Fluid3D([2583,2535,2687,2453],0); -ELEMENTS[34208] = Fluid3D([16900,17217,17221,17469],0); -ELEMENTS[34209] = Fluid3D([17217,17221,17469,17333],0); -ELEMENTS[34210] = Fluid3D([11897,11351,11483,10502],0); -ELEMENTS[34211] = Fluid3D([7845,7375,7587,8213],0); -ELEMENTS[34212] = Fluid3D([7587,7845,8213,8453],0); -ELEMENTS[34213] = Fluid3D([7845,7375,8213,8339],0); -ELEMENTS[34214] = Fluid3D([8213,7845,8339,8955],0); -ELEMENTS[34215] = Fluid3D([7375,7587,8213,7422],0); -ELEMENTS[34216] = Fluid3D([16441,16007,15775,15971],0); -ELEMENTS[34217] = Fluid3D([15135,14408,14652,14254],0); -ELEMENTS[34218] = Fluid3D([8574,8121,7917,8916],0); -ELEMENTS[34219] = Fluid3D([14881,14105,14480,14688],0); -ELEMENTS[34220] = Fluid3D([14480,14881,14688,15314],0); -ELEMENTS[34221] = Fluid3D([6314,7062,6411,6457],0); -ELEMENTS[34222] = Fluid3D([7320,7515,8304,7166],0); -ELEMENTS[34223] = Fluid3D([7703,8588,7961,8138],0); -ELEMENTS[34224] = Fluid3D([8588,7961,8138,9206],0); -ELEMENTS[34225] = Fluid3D([7961,7703,8138,7193],0); -ELEMENTS[34226] = Fluid3D([7703,8588,8138,8501],0); -ELEMENTS[34227] = Fluid3D([8138,8588,9206,9214],0); -ELEMENTS[34228] = Fluid3D([5028,5207,5671,5319],0); -ELEMENTS[34229] = Fluid3D([14713,15282,14874,15116],0); -ELEMENTS[34230] = Fluid3D([9491,8823,8556,8591],0); -ELEMENTS[34231] = Fluid3D([16339,16228,16463,15713],0); -ELEMENTS[34232] = Fluid3D([15085,14394,15041,14829],0); -ELEMENTS[34233] = Fluid3D([16077,15996,15984,15652],0); -ELEMENTS[34234] = Fluid3D([15984,16077,15652,16074],0); -ELEMENTS[34235] = Fluid3D([15996,15984,15652,15473],0); -ELEMENTS[34236] = Fluid3D([13102,13323,12560,13790],0); -ELEMENTS[34237] = Fluid3D([6543,5916,6442,6321],0); -ELEMENTS[34238] = Fluid3D([7105,8009,7318,7605],0); -ELEMENTS[34239] = Fluid3D([2081,1888,2018,1972],0); -ELEMENTS[34240] = Fluid3D([8568,8754,8299,7402],0); -ELEMENTS[34241] = Fluid3D([16573,16215,16514,16767],0); -ELEMENTS[34242] = Fluid3D([9529,9358,9464,10119],0); -ELEMENTS[34243] = Fluid3D([13061,13020,13750,13360],0); -ELEMENTS[34244] = Fluid3D([16040,15576,15865,15267],0); -ELEMENTS[34245] = Fluid3D([14887,14486,14132,14500],0); -ELEMENTS[34246] = Fluid3D([4390,4691,4141,4506],0); -ELEMENTS[34247] = Fluid3D([8284,7943,8426,9215],0); -ELEMENTS[34248] = Fluid3D([13174,12806,13577,12929],0); -ELEMENTS[34249] = Fluid3D([12806,13577,12929,13428],0); -ELEMENTS[34250] = Fluid3D([14872,14246,15076,14696],0); -ELEMENTS[34251] = Fluid3D([4672,4666,4427,4962],0); -ELEMENTS[34252] = Fluid3D([17426,17412,17156,17577],0); -ELEMENTS[34253] = Fluid3D([12228,12385,12948,11735],0); -ELEMENTS[34254] = Fluid3D([9972,9201,9904,9556],0); -ELEMENTS[34255] = Fluid3D([5151,5614,5370,5030],0); -ELEMENTS[34256] = Fluid3D([5151,5614,5030,4999],0); -ELEMENTS[34257] = Fluid3D([5614,5370,5030,5082],0); -ELEMENTS[34258] = Fluid3D([5030,5614,5082,5557],0); -ELEMENTS[34259] = Fluid3D([5030,5614,5557,5468],0); -ELEMENTS[34260] = Fluid3D([5082,5030,5557,5267],0); -ELEMENTS[34261] = Fluid3D([8708,9252,9057,9894],0); -ELEMENTS[34262] = Fluid3D([3469,3176,3507,3182],0); -ELEMENTS[34263] = Fluid3D([16425,16897,16379,16825],0); -ELEMENTS[34264] = Fluid3D([16897,16379,16825,17105],0); -ELEMENTS[34265] = Fluid3D([6102,7037,6688,6581],0); -ELEMENTS[34266] = Fluid3D([12199,12010,12280,13098],0); -ELEMENTS[34267] = Fluid3D([13942,14188,14253,14892],0); -ELEMENTS[34268] = Fluid3D([17643,17855,17560,17947],0); -ELEMENTS[34269] = Fluid3D([11617,10894,11776,10924],0); -ELEMENTS[34270] = Fluid3D([11776,11617,10924,11917],0); -ELEMENTS[34271] = Fluid3D([11617,10924,11917,11204],0); -ELEMENTS[34272] = Fluid3D([10894,11776,10924,10848],0); -ELEMENTS[34273] = Fluid3D([11617,10894,10924,9971],0); -ELEMENTS[34274] = Fluid3D([8840,8848,9377,9710],0); -ELEMENTS[34275] = Fluid3D([13657,13680,13633,12843],0); -ELEMENTS[34276] = Fluid3D([17956,17999,18192,17933],0); -ELEMENTS[34277] = Fluid3D([12302,11379,12128,12159],0); -ELEMENTS[34278] = Fluid3D([6794,7421,6588,6878],0); -ELEMENTS[34279] = Fluid3D([7421,6588,6878,7253],0); -ELEMENTS[34280] = Fluid3D([14166,13755,14514,13866],0); -ELEMENTS[34281] = Fluid3D([4448,4030,3956,3721],0); -ELEMENTS[34282] = Fluid3D([6464,6302,6935,7472],0); -ELEMENTS[34283] = Fluid3D([13256,13440,13471,14437],0); -ELEMENTS[34284] = Fluid3D([8640,7698,8417,7777],0); -ELEMENTS[34285] = Fluid3D([12493,13240,13214,13418],0); -ELEMENTS[34286] = Fluid3D([16453,16378,16200,16381],0); -ELEMENTS[34287] = Fluid3D([3290,3700,3320,3565],0); -ELEMENTS[34288] = Fluid3D([5929,5783,6387,6362],0); -ELEMENTS[34289] = Fluid3D([11371,12111,12414,11884],0); -ELEMENTS[34290] = Fluid3D([17890,18021,18072,17740],0); -ELEMENTS[34291] = Fluid3D([12660,12979,12237,12438],0); -ELEMENTS[34292] = Fluid3D([10102,10933,9950,10881],0); -ELEMENTS[34293] = Fluid3D([16459,16567,16836,16082],0); -ELEMENTS[34294] = Fluid3D([4807,4268,4450,4480],0); -ELEMENTS[34295] = Fluid3D([9860,9102,9963,9591],0); -ELEMENTS[34296] = Fluid3D([14914,14498,15284,14216],0); -ELEMENTS[34297] = Fluid3D([5053,5385,5715,5738],0); -ELEMENTS[34298] = Fluid3D([4585,4610,4094,4451],0); -ELEMENTS[34299] = Fluid3D([16894,17054,17307,17312],0); -ELEMENTS[34300] = Fluid3D([9833,10814,10018,9777],0); -ELEMENTS[34301] = Fluid3D([10018,9833,9777,8861],0); -ELEMENTS[34302] = Fluid3D([11413,11956,12085,12633],0); -ELEMENTS[34303] = Fluid3D([7663,7140,7191,7825],0); -ELEMENTS[34304] = Fluid3D([17875,17759,18067,17619],0); -ELEMENTS[34305] = Fluid3D([7243,6796,6835,6190],0); -ELEMENTS[34306] = Fluid3D([14936,14168,14181,14436],0); -ELEMENTS[34307] = Fluid3D([14316,14025,14097,14764],0); -ELEMENTS[34308] = Fluid3D([14097,14316,14764,14881],0); -ELEMENTS[34309] = Fluid3D([14316,14764,14881,15062],0); -ELEMENTS[34310] = Fluid3D([3158,3639,3189,3256],0); -ELEMENTS[34311] = Fluid3D([3639,3189,3256,3638],0); -ELEMENTS[34312] = Fluid3D([6156,5952,6397,5535],0); -ELEMENTS[34313] = Fluid3D([12923,13453,13369,12646],0); -ELEMENTS[34314] = Fluid3D([9761,9877,9014,9902],0); -ELEMENTS[34315] = Fluid3D([16148,15564,15701,16263],0); -ELEMENTS[34316] = Fluid3D([8676,9366,9089,8269],0); -ELEMENTS[34317] = Fluid3D([12422,12837,12034,12873],0); -ELEMENTS[34318] = Fluid3D([12034,12422,12873,11795],0); -ELEMENTS[34319] = Fluid3D([12837,12034,12873,13407],0); -ELEMENTS[34320] = Fluid3D([12422,12837,12873,13492],0); -ELEMENTS[34321] = Fluid3D([17647,17349,17348,17589],0); -ELEMENTS[34322] = Fluid3D([16812,16410,16454,16275],0); -ELEMENTS[34323] = Fluid3D([12046,11885,12220,11070],0); -ELEMENTS[34324] = Fluid3D([7356,7597,6893,7713],0); -ELEMENTS[34325] = Fluid3D([2768,2694,3025,2637],0); -ELEMENTS[34326] = Fluid3D([8754,9098,8246,8398],0); -ELEMENTS[34327] = Fluid3D([18485,18333,18380,18451],0); -ELEMENTS[34328] = Fluid3D([8134,7605,7509,8500],0); -ELEMENTS[34329] = Fluid3D([14529,15239,15030,14508],0); -ELEMENTS[34330] = Fluid3D([14214,14350,13990,14744],0); -ELEMENTS[34331] = Fluid3D([13990,14214,14744,14661],0); -ELEMENTS[34332] = Fluid3D([14744,13990,14661,14665],0); -ELEMENTS[34333] = Fluid3D([14214,14350,14744,15060],0); -ELEMENTS[34334] = Fluid3D([14744,14214,15060,15234],0); -ELEMENTS[34335] = Fluid3D([15060,14744,15234,15106],0); -ELEMENTS[34336] = Fluid3D([15060,14744,15106,14350],0); -ELEMENTS[34337] = Fluid3D([14744,15234,15106,14661],0); -ELEMENTS[34338] = Fluid3D([15106,14744,14661,14665],0); -ELEMENTS[34339] = Fluid3D([15106,14744,14665,14350],0); -ELEMENTS[34340] = Fluid3D([14744,15234,14661,14560],0); -ELEMENTS[34341] = Fluid3D([14661,14744,14560,14214],0); -ELEMENTS[34342] = Fluid3D([14744,14560,14214,15234],0); -ELEMENTS[34343] = Fluid3D([15234,15060,15106,15604],0); -ELEMENTS[34344] = Fluid3D([15234,15060,15604,14965],0); -ELEMENTS[34345] = Fluid3D([15060,15604,14965,15302],0); -ELEMENTS[34346] = Fluid3D([14350,13990,14744,14665],0); -ELEMENTS[34347] = Fluid3D([12141,12675,12569,11950],0); -ELEMENTS[34348] = Fluid3D([6336,7153,6776,7090],0); -ELEMENTS[34349] = Fluid3D([6170,5811,5473,6320],0); -ELEMENTS[34350] = Fluid3D([13261,12334,12611,12113],0); -ELEMENTS[34351] = Fluid3D([14289,14848,14482,14910],0); -ELEMENTS[34352] = Fluid3D([14848,14482,14910,15147],0); -ELEMENTS[34353] = Fluid3D([14482,14289,14910,14133],0); -ELEMENTS[34354] = Fluid3D([14289,14848,14910,14961],0); -ELEMENTS[34355] = Fluid3D([13822,13253,14137,14047],0); -ELEMENTS[34356] = Fluid3D([13822,13253,14047,13324],0); -ELEMENTS[34357] = Fluid3D([14137,13822,14047,14933],0); -ELEMENTS[34358] = Fluid3D([13253,14047,13324,13284],0); -ELEMENTS[34359] = Fluid3D([13324,13253,13284,12544],0); -ELEMENTS[34360] = Fluid3D([13284,13324,12544,13515],0); -ELEMENTS[34361] = Fluid3D([13284,13324,13515,13927],0); -ELEMENTS[34362] = Fluid3D([13324,13515,13927,13060],0); -ELEMENTS[34363] = Fluid3D([13324,13515,13060,12544],0); -ELEMENTS[34364] = Fluid3D([13060,13324,12544,13253],0); -ELEMENTS[34365] = Fluid3D([13284,13324,13927,14047],0); -ELEMENTS[34366] = Fluid3D([13515,13284,13927,14009],0); -ELEMENTS[34367] = Fluid3D([13324,13927,14047,13822],0); -ELEMENTS[34368] = Fluid3D([13927,13284,14047,14009],0); -ELEMENTS[34369] = Fluid3D([14047,13927,14009,14933],0); -ELEMENTS[34370] = Fluid3D([12544,13284,13515,12855],0); -ELEMENTS[34371] = Fluid3D([12544,13284,12855,13245],0); -ELEMENTS[34372] = Fluid3D([13284,12855,13245,13468],0); -ELEMENTS[34373] = Fluid3D([13284,13515,12855,13468],0); -ELEMENTS[34374] = Fluid3D([12544,13284,13245,13253],0); -ELEMENTS[34375] = Fluid3D([13284,13245,13253,14009],0); -ELEMENTS[34376] = Fluid3D([13284,13245,14009,13468],0); -ELEMENTS[34377] = Fluid3D([14047,13927,14933,14512],0); -ELEMENTS[34378] = Fluid3D([14933,14047,14512,13822],0); -ELEMENTS[34379] = Fluid3D([14047,13927,14512,13822],0); -ELEMENTS[34380] = Fluid3D([13927,13324,13060,13822],0); -ELEMENTS[34381] = Fluid3D([13324,13060,13822,13253],0); -ELEMENTS[34382] = Fluid3D([13253,14137,14047,13812],0); -ELEMENTS[34383] = Fluid3D([11800,12444,11475,12015],0); -ELEMENTS[34384] = Fluid3D([11800,12444,12015,12704],0); -ELEMENTS[34385] = Fluid3D([11475,11800,12015,11057],0); -ELEMENTS[34386] = Fluid3D([11475,11800,11057,10429],0); -ELEMENTS[34387] = Fluid3D([12015,11475,11057,11095],0); -ELEMENTS[34388] = Fluid3D([12444,11475,12015,12432],0); -ELEMENTS[34389] = Fluid3D([11800,12015,11057,11823],0); -ELEMENTS[34390] = Fluid3D([4592,4548,5077,4603],0); -ELEMENTS[34391] = Fluid3D([17232,17543,17540,17045],0); -ELEMENTS[34392] = Fluid3D([9429,10068,10074,9279],0); -ELEMENTS[34393] = Fluid3D([10068,10074,9279,10154],0); -ELEMENTS[34394] = Fluid3D([10074,9279,10154,9859],0); -ELEMENTS[34395] = Fluid3D([10068,10074,10154,11002],0); -ELEMENTS[34396] = Fluid3D([10114,11121,10458,10472],0); -ELEMENTS[34397] = Fluid3D([16800,16644,17032,16986],0); -ELEMENTS[34398] = Fluid3D([9111,8830,8382,9012],0); -ELEMENTS[34399] = Fluid3D([8830,8382,9012,8330],0); -ELEMENTS[34400] = Fluid3D([9012,8830,8330,9753],0); -ELEMENTS[34401] = Fluid3D([9111,8830,9012,9905],0); -ELEMENTS[34402] = Fluid3D([8830,9012,9905,9753],0); -ELEMENTS[34403] = Fluid3D([8382,9111,9012,9430],0); -ELEMENTS[34404] = Fluid3D([7407,6739,6615,6528],0); -ELEMENTS[34405] = Fluid3D([6541,7311,7078,7190],0); -ELEMENTS[34406] = Fluid3D([15715,15680,15115,15313],0); -ELEMENTS[34407] = Fluid3D([15115,15715,15313,14802],0); -ELEMENTS[34408] = Fluid3D([15680,15115,15313,14960],0); -ELEMENTS[34409] = Fluid3D([15680,15115,14960,15434],0); -ELEMENTS[34410] = Fluid3D([15115,15313,14960,14802],0); -ELEMENTS[34411] = Fluid3D([15115,14960,15434,14423],0); -ELEMENTS[34412] = Fluid3D([15115,14960,14423,14142],0); -ELEMENTS[34413] = Fluid3D([15715,15680,15313,16053],0); -ELEMENTS[34414] = Fluid3D([3625,3457,3577,3955],0); -ELEMENTS[34415] = Fluid3D([2528,2627,2425,2368],0); -ELEMENTS[34416] = Fluid3D([2627,2425,2368,2568],0); -ELEMENTS[34417] = Fluid3D([13737,13842,13136,13815],0); -ELEMENTS[34418] = Fluid3D([14027,13341,13715,14323],0); -ELEMENTS[34419] = Fluid3D([16909,16872,16363,16744],0); -ELEMENTS[34420] = Fluid3D([16363,16909,16744,16818],0); -ELEMENTS[34421] = Fluid3D([16909,16744,16818,17235],0); -ELEMENTS[34422] = Fluid3D([16909,16872,16744,17235],0); -ELEMENTS[34423] = Fluid3D([16872,16363,16744,16538],0); -ELEMENTS[34424] = Fluid3D([16363,16744,16538,16336],0); -ELEMENTS[34425] = Fluid3D([16872,16363,16538,16199],0); -ELEMENTS[34426] = Fluid3D([16744,16872,16538,16817],0); -ELEMENTS[34427] = Fluid3D([16538,16744,16817,16336],0); -ELEMENTS[34428] = Fluid3D([16538,16336,16673,16199],0); -ELEMENTS[34429] = Fluid3D([16538,16336,16199,16363],0); -ELEMENTS[34430] = Fluid3D([16744,16872,16817,17235],0); -ELEMENTS[34431] = Fluid3D([16336,16673,16199,16237],0); -ELEMENTS[34432] = Fluid3D([16673,16199,16237,16427],0); -ELEMENTS[34433] = Fluid3D([16673,16199,16427,16692],0); -ELEMENTS[34434] = Fluid3D([16199,16692,16563,16454],0); -ELEMENTS[34435] = Fluid3D([16692,16563,16454,17171],0); -ELEMENTS[34436] = Fluid3D([16199,16427,16692,16275],0); -ELEMENTS[34437] = Fluid3D([16427,16692,16275,16812],0); -ELEMENTS[34438] = Fluid3D([16199,16427,16275,15906],0); -ELEMENTS[34439] = Fluid3D([16427,16275,15906,16209],0); -ELEMENTS[34440] = Fluid3D([16199,16427,15906,16237],0); -ELEMENTS[34441] = Fluid3D([16275,16427,16812,16625],0); -ELEMENTS[34442] = Fluid3D([16275,16427,16625,16209],0); -ELEMENTS[34443] = Fluid3D([11964,12817,12020,12180],0); -ELEMENTS[34444] = Fluid3D([3206,3617,3237,3129],0); -ELEMENTS[34445] = Fluid3D([8639,8250,8692,7618],0); -ELEMENTS[34446] = Fluid3D([7926,7250,7119,7353],0); -ELEMENTS[34447] = Fluid3D([7119,7926,7353,7867],0); -ELEMENTS[34448] = Fluid3D([7926,7250,7353,8006],0); -ELEMENTS[34449] = Fluid3D([7250,7119,7353,6509],0); -ELEMENTS[34450] = Fluid3D([7119,7353,6509,6805],0); -ELEMENTS[34451] = Fluid3D([7353,6509,6805,6953],0); -ELEMENTS[34452] = Fluid3D([7119,7353,6805,7867],0); -ELEMENTS[34453] = Fluid3D([6805,7353,6953,7112],0); -ELEMENTS[34454] = Fluid3D([7353,6509,6953,7250],0); -ELEMENTS[34455] = Fluid3D([6509,7119,6805,6181],0); -ELEMENTS[34456] = Fluid3D([6953,7353,7250,7472],0); -ELEMENTS[34457] = Fluid3D([7250,7119,6509,6332],0); -ELEMENTS[34458] = Fluid3D([6509,7250,6332,6302],0); -ELEMENTS[34459] = Fluid3D([9271,8205,8546,9183],0); -ELEMENTS[34460] = Fluid3D([8546,9271,9183,10206],0); -ELEMENTS[34461] = Fluid3D([8205,8546,9183,8176],0); -ELEMENTS[34462] = Fluid3D([8546,9183,8176,9498],0); -ELEMENTS[34463] = Fluid3D([8546,9183,9498,10206],0); -ELEMENTS[34464] = Fluid3D([15281,14832,15238,15693],0); -ELEMENTS[34465] = Fluid3D([15238,15281,15693,15219],0); -ELEMENTS[34466] = Fluid3D([10911,10309,9884,10326],0); -ELEMENTS[34467] = Fluid3D([6678,7222,7558,7127],0); -ELEMENTS[34468] = Fluid3D([5851,6496,6329,6812],0); -ELEMENTS[34469] = Fluid3D([12344,12417,13103,13333],0); -ELEMENTS[34470] = Fluid3D([13103,12344,13333,12484],0); -ELEMENTS[34471] = Fluid3D([11630,12592,12325,11769],0); -ELEMENTS[34472] = Fluid3D([12319,13217,12193,12064],0); -ELEMENTS[34473] = Fluid3D([8417,9359,8804,8640],0); -ELEMENTS[34474] = Fluid3D([8417,9359,8640,8751],0); -ELEMENTS[34475] = Fluid3D([15648,15336,15007,15209],0); -ELEMENTS[34476] = Fluid3D([15336,15007,15209,14761],0); -ELEMENTS[34477] = Fluid3D([15007,15209,14761,14298],0); -ELEMENTS[34478] = Fluid3D([15007,15648,15209,15413],0); -ELEMENTS[34479] = Fluid3D([15209,15007,15413,14572],0); -ELEMENTS[34480] = Fluid3D([15007,15648,15413,15360],0); -ELEMENTS[34481] = Fluid3D([15209,15336,14761,14920],0); -ELEMENTS[34482] = Fluid3D([14761,15209,14920,14621],0); -ELEMENTS[34483] = Fluid3D([14920,14761,14621,14082],0); -ELEMENTS[34484] = Fluid3D([14920,14761,14082,14775],0); -ELEMENTS[34485] = Fluid3D([14920,14761,14775,15119],0); -ELEMENTS[34486] = Fluid3D([14920,14761,15119,15336],0); -ELEMENTS[34487] = Fluid3D([14775,14920,15119,15582],0); -ELEMENTS[34488] = Fluid3D([14920,15119,15582,15509],0); -ELEMENTS[34489] = Fluid3D([14920,15119,15509,15336],0); -ELEMENTS[34490] = Fluid3D([15582,14920,15509,15749],0); -ELEMENTS[34491] = Fluid3D([15119,15582,15509,16174],0); -ELEMENTS[34492] = Fluid3D([14761,14775,15119,14337],0); -ELEMENTS[34493] = Fluid3D([15119,15509,15336,15420],0); -ELEMENTS[34494] = Fluid3D([11419,12090,12295,12544],0); -ELEMENTS[34495] = Fluid3D([9655,9535,8844,8721],0); -ELEMENTS[34496] = Fluid3D([16859,16810,17003,17204],0); -ELEMENTS[34497] = Fluid3D([13473,13393,13677,13144],0); -ELEMENTS[34498] = Fluid3D([13677,13473,13144,14170],0); -ELEMENTS[34499] = Fluid3D([13144,13677,14170,14132],0); -ELEMENTS[34500] = Fluid3D([13677,14170,14132,14630],0); -ELEMENTS[34501] = Fluid3D([16933,17289,17261,16861],0); -ELEMENTS[34502] = Fluid3D([17289,17261,16861,17297],0); -ELEMENTS[34503] = Fluid3D([16933,17289,16861,16723],0); -ELEMENTS[34504] = Fluid3D([3062,3381,3233,2913],0); -ELEMENTS[34505] = Fluid3D([10910,11810,11293,10403],0); -ELEMENTS[34506] = Fluid3D([11838,12092,11228,11509],0); -ELEMENTS[34507] = Fluid3D([8519,8470,8723,7719],0); -ELEMENTS[34508] = Fluid3D([13245,12985,13311,12501],0); -ELEMENTS[34509] = Fluid3D([18127,18246,18035,18284],0); -ELEMENTS[34510] = Fluid3D([18246,18035,18284,18162],0); -ELEMENTS[34511] = Fluid3D([8166,7333,8333,7475],0); -ELEMENTS[34512] = Fluid3D([8801,8329,8007,8219],0); -ELEMENTS[34513] = Fluid3D([4840,5192,4637,5250],0); -ELEMENTS[34514] = Fluid3D([5192,4637,5250,5358],0); -ELEMENTS[34515] = Fluid3D([4840,5192,5250,5494],0); -ELEMENTS[34516] = Fluid3D([4637,4840,5250,5053],0); -ELEMENTS[34517] = Fluid3D([15627,16098,16151,16125],0); -ELEMENTS[34518] = Fluid3D([16382,16687,16145,16716],0); -ELEMENTS[34519] = Fluid3D([15254,15055,15548,15326],0); -ELEMENTS[34520] = Fluid3D([15548,15254,15326,15728],0); -ELEMENTS[34521] = Fluid3D([13785,13940,13313,14427],0); -ELEMENTS[34522] = Fluid3D([2854,2899,2749,2517],0); -ELEMENTS[34523] = Fluid3D([3169,3019,3388,3497],0); -ELEMENTS[34524] = Fluid3D([3388,3169,3497,3336],0); -ELEMENTS[34525] = Fluid3D([8252,8094,8231,7260],0); -ELEMENTS[34526] = Fluid3D([10809,10993,10087,10228],0); -ELEMENTS[34527] = Fluid3D([7712,7365,6879,7392],0); -ELEMENTS[34528] = Fluid3D([12404,12575,13138,13618],0); -ELEMENTS[34529] = Fluid3D([11757,11542,11131,10705],0); -ELEMENTS[34530] = Fluid3D([17409,17605,17344,17535],0); -ELEMENTS[34531] = Fluid3D([10998,11529,11977,11186],0); -ELEMENTS[34532] = Fluid3D([7210,8019,7716,7628],0); -ELEMENTS[34533] = Fluid3D([7961,8102,7272,8174],0); -ELEMENTS[34534] = Fluid3D([7961,8102,8174,8919],0); -ELEMENTS[34535] = Fluid3D([6863,6196,6982,6910],0); -ELEMENTS[34536] = Fluid3D([14393,14615,14812,14147],0); -ELEMENTS[34537] = Fluid3D([14615,14812,14147,14491],0); -ELEMENTS[34538] = Fluid3D([14393,14615,14147,14018],0); -ELEMENTS[34539] = Fluid3D([14147,14615,14491,14075],0); -ELEMENTS[34540] = Fluid3D([14147,14615,14075,14018],0); -ELEMENTS[34541] = Fluid3D([14812,14393,14147,14093],0); -ELEMENTS[34542] = Fluid3D([14147,14812,14093,14019],0); -ELEMENTS[34543] = Fluid3D([7114,7544,7813,7893],0); -ELEMENTS[34544] = Fluid3D([11259,10898,11133,12010],0); -ELEMENTS[34545] = Fluid3D([7542,8308,7498,7220],0); -ELEMENTS[34546] = Fluid3D([13957,13135,13609,13081],0); -ELEMENTS[34547] = Fluid3D([15658,15913,15927,15587],0); -ELEMENTS[34548] = Fluid3D([15658,15913,15587,15182],0); -ELEMENTS[34549] = Fluid3D([15913,15587,15182,15555],0); -ELEMENTS[34550] = Fluid3D([15913,15587,15555,16137],0); -ELEMENTS[34551] = Fluid3D([15913,15927,15587,16060],0); -ELEMENTS[34552] = Fluid3D([15587,15913,16060,16137],0); -ELEMENTS[34553] = Fluid3D([15913,15927,16060,16736],0); -ELEMENTS[34554] = Fluid3D([12335,11456,11512,11741],0); -ELEMENTS[34555] = Fluid3D([8224,7777,7511,7597],0); -ELEMENTS[34556] = Fluid3D([7777,7511,7597,6636],0); -ELEMENTS[34557] = Fluid3D([8224,7777,7597,8163],0); -ELEMENTS[34558] = Fluid3D([7777,7597,8163,8220],0); -ELEMENTS[34559] = Fluid3D([5530,5830,5278,5266],0); -ELEMENTS[34560] = Fluid3D([5830,5278,5266,5523],0); -ELEMENTS[34561] = Fluid3D([5266,5830,5523,5808],0); -ELEMENTS[34562] = Fluid3D([5523,5266,5808,4998],0); -ELEMENTS[34563] = Fluid3D([5523,5266,4998,4963],0); -ELEMENTS[34564] = Fluid3D([5266,5830,5808,5993],0); -ELEMENTS[34565] = Fluid3D([5830,5523,5808,6131],0); -ELEMENTS[34566] = Fluid3D([5278,5530,5266,4850],0); -ELEMENTS[34567] = Fluid3D([5530,5830,5266,5993],0); -ELEMENTS[34568] = Fluid3D([1888,1997,2018,1831],0); -ELEMENTS[34569] = Fluid3D([10985,10630,11364,11042],0); -ELEMENTS[34570] = Fluid3D([10985,10630,11042,10698],0); -ELEMENTS[34571] = Fluid3D([10630,11042,10698,9985],0); -ELEMENTS[34572] = Fluid3D([11042,10985,10698,11419],0); -ELEMENTS[34573] = Fluid3D([15931,16086,15617,15306],0); -ELEMENTS[34574] = Fluid3D([9887,9845,9204,9051],0); -ELEMENTS[34575] = Fluid3D([9887,9845,9051,10540],0); -ELEMENTS[34576] = Fluid3D([9845,9204,9051,8781],0); -ELEMENTS[34577] = Fluid3D([9204,9887,9051,8506],0); -ELEMENTS[34578] = Fluid3D([9051,9204,8506,7914],0); -ELEMENTS[34579] = Fluid3D([17058,17156,17012,16748],0); -ELEMENTS[34580] = Fluid3D([17156,17012,16748,17071],0); -ELEMENTS[34581] = Fluid3D([16748,17156,17071,16932],0); -ELEMENTS[34582] = Fluid3D([17058,17156,16748,16975],0); -ELEMENTS[34583] = Fluid3D([17156,16748,16975,16932],0); -ELEMENTS[34584] = Fluid3D([17156,17012,17071,17502],0); -ELEMENTS[34585] = Fluid3D([4169,4356,4625,3984],0); -ELEMENTS[34586] = Fluid3D([16735,16273,16383,16150],0); -ELEMENTS[34587] = Fluid3D([16273,16383,16150,15760],0); -ELEMENTS[34588] = Fluid3D([16720,16434,16931,16384],0); -ELEMENTS[34589] = Fluid3D([2957,3018,3247,3024],0); -ELEMENTS[34590] = Fluid3D([6153,5741,6372,5733],0); -ELEMENTS[34591] = Fluid3D([14970,14717,14476,14262],0); -ELEMENTS[34592] = Fluid3D([8437,7929,7550,7603],0); -ELEMENTS[34593] = Fluid3D([14470,14530,14760,15291],0); -ELEMENTS[34594] = Fluid3D([2550,2747,2743,2804],0); -ELEMENTS[34595] = Fluid3D([15439,15700,14946,15743],0); -ELEMENTS[34596] = Fluid3D([15203,14918,15346,15669],0); -ELEMENTS[34597] = Fluid3D([11856,11530,11212,12182],0); -ELEMENTS[34598] = Fluid3D([13539,14309,13871,14343],0); -ELEMENTS[34599] = Fluid3D([14309,13871,14343,14576],0); -ELEMENTS[34600] = Fluid3D([14343,14309,14576,15057],0); -ELEMENTS[34601] = Fluid3D([10425,9696,10540,9887],0); -ELEMENTS[34602] = Fluid3D([7579,6773,7597,6636],0); -ELEMENTS[34603] = Fluid3D([14304,14160,14587,13994],0); -ELEMENTS[34604] = Fluid3D([9487,9072,8531,9104],0); -ELEMENTS[34605] = Fluid3D([17996,18038,17787,17782],0); -ELEMENTS[34606] = Fluid3D([13244,13194,13978,13749],0); -ELEMENTS[34607] = Fluid3D([12063,12462,12913,11989],0); -ELEMENTS[34608] = Fluid3D([12063,12462,11989,11322],0); -ELEMENTS[34609] = Fluid3D([12462,12913,11989,13035],0); -ELEMENTS[34610] = Fluid3D([11989,12462,13035,11876],0); -ELEMENTS[34611] = Fluid3D([12462,12913,13035,13509],0); -ELEMENTS[34612] = Fluid3D([13035,12462,13509,13190],0); -ELEMENTS[34613] = Fluid3D([13509,13035,13190,13868],0); -ELEMENTS[34614] = Fluid3D([13509,13035,13868,14004],0); -ELEMENTS[34615] = Fluid3D([12913,12063,11989,12023],0); -ELEMENTS[34616] = Fluid3D([12063,11989,12023,11004],0); -ELEMENTS[34617] = Fluid3D([12913,12063,12023,12627],0); -ELEMENTS[34618] = Fluid3D([11989,12462,11876,11322],0); -ELEMENTS[34619] = Fluid3D([13035,13190,13868,12721],0); -ELEMENTS[34620] = Fluid3D([13190,13509,13868,14361],0); -ELEMENTS[34621] = Fluid3D([13232,12783,13512,13041],0); -ELEMENTS[34622] = Fluid3D([12738,12469,12894,11726],0); -ELEMENTS[34623] = Fluid3D([6149,6254,6514,7089],0); -ELEMENTS[34624] = Fluid3D([6514,6149,7089,6811],0); -ELEMENTS[34625] = Fluid3D([6149,7089,6811,6763],0); -ELEMENTS[34626] = Fluid3D([5863,5432,6028,5299],0); -ELEMENTS[34627] = Fluid3D([13207,13816,13637,12801],0); -ELEMENTS[34628] = Fluid3D([5304,5211,5490,5046],0); -ELEMENTS[34629] = Fluid3D([16003,16507,16021,16316],0); -ELEMENTS[34630] = Fluid3D([7230,7106,6757,6630],0); -ELEMENTS[34631] = Fluid3D([7230,7106,6630,7223],0); -ELEMENTS[34632] = Fluid3D([6630,7230,7223,7023],0); -ELEMENTS[34633] = Fluid3D([6757,7230,6630,6710],0); -ELEMENTS[34634] = Fluid3D([7106,6757,6630,6316],0); -ELEMENTS[34635] = Fluid3D([6630,7106,6316,6014],0); -ELEMENTS[34636] = Fluid3D([7106,6630,7223,7113],0); -ELEMENTS[34637] = Fluid3D([6757,6630,6316,5852],0); -ELEMENTS[34638] = Fluid3D([7106,6757,6316,7158],0); -ELEMENTS[34639] = Fluid3D([7427,7233,7537,8137],0); -ELEMENTS[34640] = Fluid3D([7233,7537,8137,7671],0); -ELEMENTS[34641] = Fluid3D([8137,7233,7671,8015],0); -ELEMENTS[34642] = Fluid3D([7233,7537,7671,7330],0); -ELEMENTS[34643] = Fluid3D([7537,7671,7330,8376],0); -ELEMENTS[34644] = Fluid3D([7671,7330,8376,8015],0); -ELEMENTS[34645] = Fluid3D([8376,7671,8015,8137],0); -ELEMENTS[34646] = Fluid3D([7671,7330,8015,7228],0); -ELEMENTS[34647] = Fluid3D([8015,7671,7228,7233],0); -ELEMENTS[34648] = Fluid3D([7671,7330,7228,7233],0); -ELEMENTS[34649] = Fluid3D([8376,7671,8137,7537],0); -ELEMENTS[34650] = Fluid3D([15012,14395,14883,14785],0); -ELEMENTS[34651] = Fluid3D([11966,13021,12932,13126],0); -ELEMENTS[34652] = Fluid3D([6163,6855,6527,6797],0); -ELEMENTS[34653] = Fluid3D([6669,6464,6460,7115],0); -ELEMENTS[34654] = Fluid3D([6464,6460,7115,6934],0); -ELEMENTS[34655] = Fluid3D([6460,7115,6934,7420],0); -ELEMENTS[34656] = Fluid3D([6669,6464,7115,7472],0); -ELEMENTS[34657] = Fluid3D([6460,6669,7115,7420],0); -ELEMENTS[34658] = Fluid3D([7115,6464,6934,6954],0); -ELEMENTS[34659] = Fluid3D([6669,7115,7420,7842],0); -ELEMENTS[34660] = Fluid3D([7115,7420,7842,7910],0); -ELEMENTS[34661] = Fluid3D([7420,7842,7910,8469],0); -ELEMENTS[34662] = Fluid3D([7115,7420,7910,6934],0); -ELEMENTS[34663] = Fluid3D([11110,10392,10356,10255],0); -ELEMENTS[34664] = Fluid3D([5374,5395,5572,4756],0); -ELEMENTS[34665] = Fluid3D([15526,15726,15999,15822],0); -ELEMENTS[34666] = Fluid3D([11282,11118,11447,10407],0); -ELEMENTS[34667] = Fluid3D([7753,7113,6987,7854],0); -ELEMENTS[34668] = Fluid3D([13061,13750,13634,13692],0); -ELEMENTS[34669] = Fluid3D([13634,13061,13692,13155],0); -ELEMENTS[34670] = Fluid3D([13061,13750,13692,13360],0); -ELEMENTS[34671] = Fluid3D([13750,13634,13692,14524],0); -ELEMENTS[34672] = Fluid3D([13692,13061,13360,12796],0); -ELEMENTS[34673] = Fluid3D([13692,13061,12796,13155],0); -ELEMENTS[34674] = Fluid3D([13863,14504,14564,14849],0); -ELEMENTS[34675] = Fluid3D([16444,16167,16068,16611],0); -ELEMENTS[34676] = Fluid3D([3723,3568,3902,3356],0); -ELEMENTS[34677] = Fluid3D([15677,15842,16260,15831],0); -ELEMENTS[34678] = Fluid3D([6335,6402,5786,6164],0); -ELEMENTS[34679] = Fluid3D([11390,12313,12093,12050],0); -ELEMENTS[34680] = Fluid3D([10419,10249,9629,9959],0); -ELEMENTS[34681] = Fluid3D([10419,10249,9959,10844],0); -ELEMENTS[34682] = Fluid3D([9959,10419,10844,10594],0); -ELEMENTS[34683] = Fluid3D([9629,10419,9959,9766],0); -ELEMENTS[34684] = Fluid3D([10249,9629,9959,8820],0); -ELEMENTS[34685] = Fluid3D([10249,9959,10844,10277],0); -ELEMENTS[34686] = Fluid3D([17759,17619,17721,18067],0); -ELEMENTS[34687] = Fluid3D([12378,12717,12942,13510],0); -ELEMENTS[34688] = Fluid3D([9798,9969,10555,9853],0); -ELEMENTS[34689] = Fluid3D([5105,5570,5748,5612],0); -ELEMENTS[34690] = Fluid3D([3696,3570,3909,4007],0); -ELEMENTS[34691] = Fluid3D([9434,9566,9648,9075],0); -ELEMENTS[34692] = Fluid3D([9566,9648,9075,9472],0); -ELEMENTS[34693] = Fluid3D([9434,9566,9075,8151],0); -ELEMENTS[34694] = Fluid3D([9075,9566,9472,9940],0); -ELEMENTS[34695] = Fluid3D([5521,4954,5359,5173],0); -ELEMENTS[34696] = Fluid3D([17966,18060,18210,18238],0); -ELEMENTS[34697] = Fluid3D([11722,12035,10984,11524],0); -ELEMENTS[34698] = Fluid3D([11722,12035,11524,12582],0); -ELEMENTS[34699] = Fluid3D([10984,11722,11524,10500],0); -ELEMENTS[34700] = Fluid3D([3176,3507,3182,3074],0); -ELEMENTS[34701] = Fluid3D([4134,4493,4045,3755],0); -ELEMENTS[34702] = Fluid3D([12269,12532,12009,11977],0); -ELEMENTS[34703] = Fluid3D([12269,12532,11977,12857],0); -ELEMENTS[34704] = Fluid3D([12532,12009,11977,12176],0); -ELEMENTS[34705] = Fluid3D([12009,12269,11977,11199],0); -ELEMENTS[34706] = Fluid3D([12269,11977,11199,12319],0); -ELEMENTS[34707] = Fluid3D([11977,12532,12176,12497],0); -ELEMENTS[34708] = Fluid3D([11977,12532,12497,12430],0); -ELEMENTS[34709] = Fluid3D([11977,12532,12430,12857],0); -ELEMENTS[34710] = Fluid3D([12532,12497,12430,13301],0); -ELEMENTS[34711] = Fluid3D([12532,12176,12497,13416],0); -ELEMENTS[34712] = Fluid3D([12497,12532,13416,13301],0); -ELEMENTS[34713] = Fluid3D([11199,12269,12319,12064],0); -ELEMENTS[34714] = Fluid3D([6296,5683,6585,6159],0); -ELEMENTS[34715] = Fluid3D([6585,6296,6159,6614],0); -ELEMENTS[34716] = Fluid3D([11412,11683,11516,12118],0); -ELEMENTS[34717] = Fluid3D([11412,11683,12118,11852],0); -ELEMENTS[34718] = Fluid3D([11516,11412,12118,12175],0); -ELEMENTS[34719] = Fluid3D([17602,17512,17500,17836],0); -ELEMENTS[34720] = Fluid3D([8549,8465,9348,7934],0); -ELEMENTS[34721] = Fluid3D([3874,3442,3764,3676],0); -ELEMENTS[34722] = Fluid3D([4232,4128,4700,4110],0); -ELEMENTS[34723] = Fluid3D([6149,6254,7089,6571],0); -ELEMENTS[34724] = Fluid3D([17146,17225,17530,17447],0); -ELEMENTS[34725] = Fluid3D([13892,13792,13271,12736],0); -ELEMENTS[34726] = Fluid3D([18436,18460,18545,18443],0); -ELEMENTS[34727] = Fluid3D([18069,18235,18252,18287],0); -ELEMENTS[34728] = Fluid3D([18235,18252,18287,18434],0); -ELEMENTS[34729] = Fluid3D([12526,11640,11863,11958],0); -ELEMENTS[34730] = Fluid3D([11744,12486,12351,12783],0); -ELEMENTS[34731] = Fluid3D([13302,13339,13596,12802],0); -ELEMENTS[34732] = Fluid3D([4795,4295,4343,4797],0); -ELEMENTS[34733] = Fluid3D([5673,5517,5855,5351],0); -ELEMENTS[34734] = Fluid3D([5673,5517,5351,4952],0); -ELEMENTS[34735] = Fluid3D([2924,2677,2613,2740],0); -ELEMENTS[34736] = Fluid3D([15998,16051,15477,15805],0); -ELEMENTS[34737] = Fluid3D([2859,2649,3041,3050],0); -ELEMENTS[34738] = Fluid3D([12655,12976,11944,12688],0); -ELEMENTS[34739] = Fluid3D([4928,4888,5163,5760],0); -ELEMENTS[34740] = Fluid3D([14650,14081,14899,15149],0); -ELEMENTS[34741] = Fluid3D([14899,14650,15149,15356],0); -ELEMENTS[34742] = Fluid3D([14899,14650,15356,15103],0); -ELEMENTS[34743] = Fluid3D([12960,12784,13356,13844],0); -ELEMENTS[34744] = Fluid3D([12784,13356,13844,12996],0); -ELEMENTS[34745] = Fluid3D([13356,12960,13844,14135],0); -ELEMENTS[34746] = Fluid3D([13844,13356,14135,14207],0); -ELEMENTS[34747] = Fluid3D([13844,13356,14207,13974],0); -ELEMENTS[34748] = Fluid3D([13844,13356,13974,12996],0); -ELEMENTS[34749] = Fluid3D([13356,14207,13974,14044],0); -ELEMENTS[34750] = Fluid3D([14207,13974,14044,14801],0); -ELEMENTS[34751] = Fluid3D([13974,13356,14044,13246],0); -ELEMENTS[34752] = Fluid3D([13974,13356,13246,12996],0); -ELEMENTS[34753] = Fluid3D([14044,13974,13246,13671],0); -ELEMENTS[34754] = Fluid3D([14044,13974,13671,14334],0); -ELEMENTS[34755] = Fluid3D([14044,13974,14334,14801],0); -ELEMENTS[34756] = Fluid3D([13974,13671,14334,13546],0); -ELEMENTS[34757] = Fluid3D([14334,13974,13546,13921],0); -ELEMENTS[34758] = Fluid3D([13671,14334,13546,14216],0); -ELEMENTS[34759] = Fluid3D([13546,13671,14216,13765],0); -ELEMENTS[34760] = Fluid3D([13546,13671,13765,12996],0); -ELEMENTS[34761] = Fluid3D([13671,14216,13765,14334],0); -ELEMENTS[34762] = Fluid3D([13974,13671,13546,12996],0); -ELEMENTS[34763] = Fluid3D([13671,14044,14334,13765],0); -ELEMENTS[34764] = Fluid3D([13246,14044,13671,13765],0); -ELEMENTS[34765] = Fluid3D([13356,13246,12996,12784],0); -ELEMENTS[34766] = Fluid3D([4727,4175,4388,3919],0); -ELEMENTS[34767] = Fluid3D([16824,16476,16257,16589],0); -ELEMENTS[34768] = Fluid3D([12785,13180,13320,13863],0); -ELEMENTS[34769] = Fluid3D([13180,13320,13863,13626],0); -ELEMENTS[34770] = Fluid3D([13180,13320,13626,12633],0); -ELEMENTS[34771] = Fluid3D([13320,13863,13626,13799],0); -ELEMENTS[34772] = Fluid3D([13626,13320,13799,13196],0); -ELEMENTS[34773] = Fluid3D([13626,13320,13196,12633],0); -ELEMENTS[34774] = Fluid3D([7427,7233,8137,8160],0); -ELEMENTS[34775] = Fluid3D([6563,7363,7078,6867],0); -ELEMENTS[34776] = Fluid3D([13332,13139,13809,13715],0); -ELEMENTS[34777] = Fluid3D([6533,6908,6746,7410],0); -ELEMENTS[34778] = Fluid3D([14107,14088,14488,13335],0); -ELEMENTS[34779] = Fluid3D([17764,18023,17652,17982],0); -ELEMENTS[34780] = Fluid3D([17652,17764,17982,17530],0); -ELEMENTS[34781] = Fluid3D([13350,13875,14180,14546],0); -ELEMENTS[34782] = Fluid3D([13875,14180,14546,14664],0); -ELEMENTS[34783] = Fluid3D([13875,14180,14664,14065],0); -ELEMENTS[34784] = Fluid3D([14180,14546,14664,14954],0); -ELEMENTS[34785] = Fluid3D([14180,14546,14954,14962],0); -ELEMENTS[34786] = Fluid3D([14546,14954,14962,15625],0); -ELEMENTS[34787] = Fluid3D([14664,14180,14954,15146],0); -ELEMENTS[34788] = Fluid3D([14546,14664,14954,15293],0); -ELEMENTS[34789] = Fluid3D([16301,15736,16005,16195],0); -ELEMENTS[34790] = Fluid3D([5720,6058,6165,6518],0); -ELEMENTS[34791] = Fluid3D([16727,17157,17020,16868],0); -ELEMENTS[34792] = Fluid3D([7544,8083,7893,7231],0); -ELEMENTS[34793] = Fluid3D([7893,7544,7231,7114],0); -ELEMENTS[34794] = Fluid3D([10234,9896,10089,9130],0); -ELEMENTS[34795] = Fluid3D([14549,13565,14332,14159],0); -ELEMENTS[34796] = Fluid3D([14332,14549,14159,14851],0); -ELEMENTS[34797] = Fluid3D([14549,14159,14851,14507],0); -ELEMENTS[34798] = Fluid3D([14159,14851,14507,14255],0); -ELEMENTS[34799] = Fluid3D([14159,14332,14851,14868],0); -ELEMENTS[34800] = Fluid3D([14851,14159,14868,14255],0); -ELEMENTS[34801] = Fluid3D([14549,14159,14507,13349],0); -ELEMENTS[34802] = Fluid3D([14549,13565,14159,13349],0); -ELEMENTS[34803] = Fluid3D([4661,5016,4651,4763],0); -ELEMENTS[34804] = Fluid3D([5016,4651,4763,5176],0); -ELEMENTS[34805] = Fluid3D([14698,14648,14591,14068],0); -ELEMENTS[34806] = Fluid3D([14698,14648,14068,13988],0); -ELEMENTS[34807] = Fluid3D([14068,14698,13988,14377],0); -ELEMENTS[34808] = Fluid3D([14068,14698,14377,14796],0); -ELEMENTS[34809] = Fluid3D([14068,14698,14796,14982],0); -ELEMENTS[34810] = Fluid3D([13325,13963,14053,13976],0); -ELEMENTS[34811] = Fluid3D([13325,13963,13976,13489],0); -ELEMENTS[34812] = Fluid3D([18008,17743,17721,17602],0); -ELEMENTS[34813] = Fluid3D([4101,3613,3789,3927],0); -ELEMENTS[34814] = Fluid3D([3613,3789,3927,3526],0); -ELEMENTS[34815] = Fluid3D([3613,3789,3526,3335],0); -ELEMENTS[34816] = Fluid3D([3927,3613,3526,3362],0); -ELEMENTS[34817] = Fluid3D([3789,3927,3526,4120],0); -ELEMENTS[34818] = Fluid3D([4137,4369,4269,3890],0); -ELEMENTS[34819] = Fluid3D([4137,4369,3890,4275],0); -ELEMENTS[34820] = Fluid3D([11344,11556,11985,11531],0); -ELEMENTS[34821] = Fluid3D([2403,2675,2460,2314],0); -ELEMENTS[34822] = Fluid3D([10212,10643,11078,10062],0); -ELEMENTS[34823] = Fluid3D([10212,10643,10062,9656],0); -ELEMENTS[34824] = Fluid3D([15253,14584,15029,15469],0); -ELEMENTS[34825] = Fluid3D([11083,10488,11285,11422],0); -ELEMENTS[34826] = Fluid3D([11285,11083,11422,12228],0); -ELEMENTS[34827] = Fluid3D([11285,11083,12228,12217],0); -ELEMENTS[34828] = Fluid3D([14020,13694,13147,13533],0); -ELEMENTS[34829] = Fluid3D([12883,13539,13203,12858],0); -ELEMENTS[34830] = Fluid3D([13203,12883,12858,12164],0); -ELEMENTS[34831] = Fluid3D([12883,12858,12164,12423],0); -ELEMENTS[34832] = Fluid3D([13203,12883,12164,12837],0); -ELEMENTS[34833] = Fluid3D([12858,12164,12423,12475],0); -ELEMENTS[34834] = Fluid3D([12423,12858,12475,13660],0); -ELEMENTS[34835] = Fluid3D([12858,12164,12475,13203],0); -ELEMENTS[34836] = Fluid3D([12858,12475,13660,13203],0); -ELEMENTS[34837] = Fluid3D([13660,12858,13203,13539],0); -ELEMENTS[34838] = Fluid3D([12883,13539,12858,12423],0); -ELEMENTS[34839] = Fluid3D([3675,3448,3913,3388],0); -ELEMENTS[34840] = Fluid3D([2866,3188,3163,3195],0); -ELEMENTS[34841] = Fluid3D([1846,1948,1868,2057],0); -ELEMENTS[34842] = Fluid3D([8257,8195,8745,7443],0); -ELEMENTS[34843] = Fluid3D([10858,11416,11215,10282],0); -ELEMENTS[34844] = Fluid3D([11416,11215,10282,10964],0); -ELEMENTS[34845] = Fluid3D([10858,11416,10282,10747],0); -ELEMENTS[34846] = Fluid3D([11416,10282,10747,10514],0); -ELEMENTS[34847] = Fluid3D([10858,11416,10747,11735],0); -ELEMENTS[34848] = Fluid3D([11416,10747,11735,10514],0); -ELEMENTS[34849] = Fluid3D([10747,11735,10514,11287],0); -ELEMENTS[34850] = Fluid3D([10747,11735,11287,10591],0); -ELEMENTS[34851] = Fluid3D([11287,10747,10591,10061],0); -ELEMENTS[34852] = Fluid3D([10282,10747,10514,9614],0); -ELEMENTS[34853] = Fluid3D([10747,10514,9614,10061],0); -ELEMENTS[34854] = Fluid3D([10747,10514,10061,11287],0); -ELEMENTS[34855] = Fluid3D([2592,2404,2716,2739],0); -ELEMENTS[34856] = Fluid3D([17582,17845,17626,17879],0); -ELEMENTS[34857] = Fluid3D([17626,17582,17879,17706],0); -ELEMENTS[34858] = Fluid3D([6772,6481,6189,5995],0); -ELEMENTS[34859] = Fluid3D([15582,15080,15600,15197],0); -ELEMENTS[34860] = Fluid3D([15080,15600,15197,14867],0); -ELEMENTS[34861] = Fluid3D([15197,15080,14867,14775],0); -ELEMENTS[34862] = Fluid3D([15197,15080,14775,15582],0); -ELEMENTS[34863] = Fluid3D([15080,15600,14867,14835],0); -ELEMENTS[34864] = Fluid3D([15080,15600,14835,14807],0); -ELEMENTS[34865] = Fluid3D([14867,15080,14835,14319],0); -ELEMENTS[34866] = Fluid3D([14867,15080,14319,14775],0); -ELEMENTS[34867] = Fluid3D([15080,14319,14775,14807],0); -ELEMENTS[34868] = Fluid3D([14835,15080,14807,14319],0); -ELEMENTS[34869] = Fluid3D([14835,14867,14319,14255],0); -ELEMENTS[34870] = Fluid3D([15600,14867,14835,15455],0); -ELEMENTS[34871] = Fluid3D([14835,15600,15455,15339],0); -ELEMENTS[34872] = Fluid3D([15600,14867,15455,15474],0); -ELEMENTS[34873] = Fluid3D([15600,14867,15474,15197],0); -ELEMENTS[34874] = Fluid3D([14867,15474,15197,14564],0); -ELEMENTS[34875] = Fluid3D([14867,14835,15455,14799],0); -ELEMENTS[34876] = Fluid3D([15197,14867,14564,14775],0); -ELEMENTS[34877] = Fluid3D([14319,14867,14775,14564],0); -ELEMENTS[34878] = Fluid3D([16107,16119,16552,15970],0); -ELEMENTS[34879] = Fluid3D([3696,3570,4007,3476],0); -ELEMENTS[34880] = Fluid3D([17632,17490,17389,17883],0); -ELEMENTS[34881] = Fluid3D([16075,15382,15742,15989],0); -ELEMENTS[34882] = Fluid3D([15742,16075,15989,16228],0); -ELEMENTS[34883] = Fluid3D([15989,15742,16228,15713],0); -ELEMENTS[34884] = Fluid3D([16228,15989,15713,15564],0); -ELEMENTS[34885] = Fluid3D([16228,15989,15564,16148],0); -ELEMENTS[34886] = Fluid3D([15989,15713,15564,15742],0); -ELEMENTS[34887] = Fluid3D([15989,15564,16148,16263],0); -ELEMENTS[34888] = Fluid3D([15989,15564,16263,15457],0); -ELEMENTS[34889] = Fluid3D([16228,15989,16148,16263],0); -ELEMENTS[34890] = Fluid3D([16228,15989,16263,16075],0); -ELEMENTS[34891] = Fluid3D([15989,16263,16075,15382],0); -ELEMENTS[34892] = Fluid3D([15713,16228,15564,15881],0); -ELEMENTS[34893] = Fluid3D([15564,15713,15881,15053],0); -ELEMENTS[34894] = Fluid3D([15713,16228,15881,16339],0); -ELEMENTS[34895] = Fluid3D([15989,15564,15457,15382],0); -ELEMENTS[34896] = Fluid3D([15881,15713,16339,15838],0); -ELEMENTS[34897] = Fluid3D([18613,18628,18593,18535],0); -ELEMENTS[34898] = Fluid3D([14327,13928,14855,14286],0); -ELEMENTS[34899] = Fluid3D([12241,12859,11875,12972],0); -ELEMENTS[34900] = Fluid3D([12306,11750,12323,12465],0); -ELEMENTS[34901] = Fluid3D([8338,8791,8578,7808],0); -ELEMENTS[34902] = Fluid3D([11226,11962,11549,11232],0); -ELEMENTS[34903] = Fluid3D([11549,11226,11232,10461],0); -ELEMENTS[34904] = Fluid3D([11226,11962,11232,11153],0); -ELEMENTS[34905] = Fluid3D([11226,11962,11153,10576],0); -ELEMENTS[34906] = Fluid3D([11153,11226,10576,11232],0); -ELEMENTS[34907] = Fluid3D([11962,11153,10576,11059],0); -ELEMENTS[34908] = Fluid3D([11153,10576,11059,11055],0); -ELEMENTS[34909] = Fluid3D([11059,11153,11055,11962],0); -ELEMENTS[34910] = Fluid3D([2167,2420,2234,2261],0); -ELEMENTS[34911] = Fluid3D([14527,14632,15125,14458],0); -ELEMENTS[34912] = Fluid3D([14527,14632,14458,13970],0); -ELEMENTS[34913] = Fluid3D([14527,14632,13970,13731],0); -ELEMENTS[34914] = Fluid3D([15125,14527,14458,14340],0); -ELEMENTS[34915] = Fluid3D([14458,15125,14340,14611],0); -ELEMENTS[34916] = Fluid3D([13970,14527,13731,13503],0); -ELEMENTS[34917] = Fluid3D([13731,13970,13503,13300],0); -ELEMENTS[34918] = Fluid3D([13731,13970,13300,13814],0); -ELEMENTS[34919] = Fluid3D([14458,14527,13970,13503],0); -ELEMENTS[34920] = Fluid3D([14527,14458,14340,13503],0); -ELEMENTS[34921] = Fluid3D([5504,6012,5381,5700],0); -ELEMENTS[34922] = Fluid3D([14127,13544,14376,14314],0); -ELEMENTS[34923] = Fluid3D([11532,11388,11717,12322],0); -ELEMENTS[34924] = Fluid3D([11388,11717,12322,11901],0); -ELEMENTS[34925] = Fluid3D([11532,11388,12322,12113],0); -ELEMENTS[34926] = Fluid3D([11388,12322,12113,11901],0); -ELEMENTS[34927] = Fluid3D([12322,11532,12113,12611],0); -ELEMENTS[34928] = Fluid3D([12113,12322,12611,13173],0); -ELEMENTS[34929] = Fluid3D([12113,12322,13173,12437],0); -ELEMENTS[34930] = Fluid3D([12113,12322,12437,11901],0); -ELEMENTS[34931] = Fluid3D([12322,13173,12437,13023],0); -ELEMENTS[34932] = Fluid3D([13173,12437,13023,13159],0); -ELEMENTS[34933] = Fluid3D([12437,13023,13159,12380],0); -ELEMENTS[34934] = Fluid3D([12322,12611,13173,12527],0); -ELEMENTS[34935] = Fluid3D([13023,13173,13159,13672],0); -ELEMENTS[34936] = Fluid3D([13173,13159,13672,12902],0); -ELEMENTS[34937] = Fluid3D([13672,13173,12902,13261],0); -ELEMENTS[34938] = Fluid3D([13672,13173,13261,14071],0); -ELEMENTS[34939] = Fluid3D([13173,12902,13261,12113],0); -ELEMENTS[34940] = Fluid3D([13159,13672,12902,13493],0); -ELEMENTS[34941] = Fluid3D([12437,12322,13023,11901],0); -ELEMENTS[34942] = Fluid3D([13023,12437,11901,12380],0); -ELEMENTS[34943] = Fluid3D([12902,13159,13493,12638],0); -ELEMENTS[34944] = Fluid3D([13173,12437,13159,12113],0); -ELEMENTS[34945] = Fluid3D([13159,13672,13493,14179],0); -ELEMENTS[34946] = Fluid3D([12437,11901,12380,11345],0); -ELEMENTS[34947] = Fluid3D([13173,13159,12902,12113],0); -ELEMENTS[34948] = Fluid3D([12919,13638,13378,12903],0); -ELEMENTS[34949] = Fluid3D([12133,12410,12490,12976],0); -ELEMENTS[34950] = Fluid3D([7055,7348,6540,7566],0); -ELEMENTS[34951] = Fluid3D([15193,15258,14575,15502],0); -ELEMENTS[34952] = Fluid3D([12053,11135,11042,11364],0); -ELEMENTS[34953] = Fluid3D([11745,11864,10956,12069],0); -ELEMENTS[34954] = Fluid3D([2671,2947,2995,3122],0); -ELEMENTS[34955] = Fluid3D([13597,13759,14234,14707],0); -ELEMENTS[34956] = Fluid3D([6222,6215,6900,6706],0); -ELEMENTS[34957] = Fluid3D([17588,17907,17661,17819],0); -ELEMENTS[34958] = Fluid3D([5285,5265,5648,6112],0); -ELEMENTS[34959] = Fluid3D([12391,12953,13389,13680],0); -ELEMENTS[34960] = Fluid3D([16340,16794,16977,16369],0); -ELEMENTS[34961] = Fluid3D([4440,4963,4410,4890],0); -ELEMENTS[34962] = Fluid3D([17799,17905,17708,17631],0); -ELEMENTS[34963] = Fluid3D([17905,17708,17631,18043],0); -ELEMENTS[34964] = Fluid3D([17618,17624,17543,17224],0); -ELEMENTS[34965] = Fluid3D([13789,13566,13438,14099],0); -ELEMENTS[34966] = Fluid3D([13438,13789,14099,14056],0); -ELEMENTS[34967] = Fluid3D([13789,13566,14099,14283],0); -ELEMENTS[34968] = Fluid3D([14099,13789,14283,14558],0); -ELEMENTS[34969] = Fluid3D([13789,13566,14283,14027],0); -ELEMENTS[34970] = Fluid3D([13789,14283,14558,14027],0); -ELEMENTS[34971] = Fluid3D([14099,13789,14558,14056],0); -ELEMENTS[34972] = Fluid3D([17323,17497,17485,17756],0); -ELEMENTS[34973] = Fluid3D([13780,13041,13138,13193],0); -ELEMENTS[34974] = Fluid3D([13041,13138,13193,12373],0); -ELEMENTS[34975] = Fluid3D([13138,13193,12373,13715],0); -ELEMENTS[34976] = Fluid3D([13780,13041,13193,13232],0); -ELEMENTS[34977] = Fluid3D([13041,13193,13232,12351],0); -ELEMENTS[34978] = Fluid3D([13041,13193,12351,12373],0); -ELEMENTS[34979] = Fluid3D([9533,9609,10303,9413],0); -ELEMENTS[34980] = Fluid3D([9609,10303,9413,9531],0); -ELEMENTS[34981] = Fluid3D([9413,9609,9531,8759],0); -ELEMENTS[34982] = Fluid3D([9533,9609,9413,8702],0); -ELEMENTS[34983] = Fluid3D([9609,9413,8702,8759],0); -ELEMENTS[34984] = Fluid3D([9413,9533,8702,9306],0); -ELEMENTS[34985] = Fluid3D([14890,14666,14363,15370],0); -ELEMENTS[34986] = Fluid3D([8641,7715,8096,7831],0); -ELEMENTS[34987] = Fluid3D([13005,13693,12824,12674],0); -ELEMENTS[34988] = Fluid3D([4421,4584,4055,4166],0); -ELEMENTS[34989] = Fluid3D([6120,6895,6203,6768],0); -ELEMENTS[34990] = Fluid3D([16476,16566,16480,16017],0); -ELEMENTS[34991] = Fluid3D([8386,8885,7821,7678],0); -ELEMENTS[34992] = Fluid3D([7821,8386,7678,7558],0); -ELEMENTS[34993] = Fluid3D([15204,15369,15525,15859],0); -ELEMENTS[34994] = Fluid3D([15525,15204,15859,15316],0); -ELEMENTS[34995] = Fluid3D([3918,3876,3655,4048],0); -ELEMENTS[34996] = Fluid3D([3655,3918,4048,3973],0); -ELEMENTS[34997] = Fluid3D([3918,4048,3973,4293],0); -ELEMENTS[34998] = Fluid3D([3918,4048,4293,4142],0); -ELEMENTS[34999] = Fluid3D([4048,3973,4293,4403],0); -ELEMENTS[35000] = Fluid3D([4293,4048,4403,4946],0); -ELEMENTS[35001] = Fluid3D([3973,3918,4293,3943],0); -ELEMENTS[35002] = Fluid3D([3918,4293,3943,3917],0); -ELEMENTS[35003] = Fluid3D([3973,3918,3943,3525],0); -ELEMENTS[35004] = Fluid3D([3918,3943,3525,3544],0); -ELEMENTS[35005] = Fluid3D([3943,3525,3544,3734],0); -ELEMENTS[35006] = Fluid3D([3525,3918,3544,3660],0); -ELEMENTS[35007] = Fluid3D([3973,3918,3525,3655],0); -ELEMENTS[35008] = Fluid3D([4048,3973,4403,4285],0); -ELEMENTS[35009] = Fluid3D([4403,4048,4285,4946],0); -ELEMENTS[35010] = Fluid3D([3973,4403,4285,3831],0); -ELEMENTS[35011] = Fluid3D([4403,4285,3831,4617],0); -ELEMENTS[35012] = Fluid3D([4403,4285,4617,4946],0); -ELEMENTS[35013] = Fluid3D([3544,3525,3660,3204],0); -ELEMENTS[35014] = Fluid3D([3544,3525,3204,3321],0); -ELEMENTS[35015] = Fluid3D([3525,3204,3321,3383],0); -ELEMENTS[35016] = Fluid3D([3943,3973,3525,4016],0); -ELEMENTS[35017] = Fluid3D([3943,3973,4016,4293],0); -ELEMENTS[35018] = Fluid3D([4016,3943,4293,4377],0); -ELEMENTS[35019] = Fluid3D([3943,4293,4377,3917],0); -ELEMENTS[35020] = Fluid3D([4377,3943,3917,4186],0); -ELEMENTS[35021] = Fluid3D([4016,3943,4377,4488],0); -ELEMENTS[35022] = Fluid3D([4940,5450,4948,5498],0); -ELEMENTS[35023] = Fluid3D([5058,5512,5318,5929],0); -ELEMENTS[35024] = Fluid3D([7538,7556,6749,7457],0); -ELEMENTS[35025] = Fluid3D([7556,6749,7457,7164],0); -ELEMENTS[35026] = Fluid3D([7538,7556,7457,8110],0); -ELEMENTS[35027] = Fluid3D([7556,7457,8110,8068],0); -ELEMENTS[35028] = Fluid3D([7457,8110,8068,8372],0); -ELEMENTS[35029] = Fluid3D([8110,8068,8372,8692],0); -ELEMENTS[35030] = Fluid3D([8110,8068,8692,7556],0); -ELEMENTS[35031] = Fluid3D([8068,7457,8372,7181],0); -ELEMENTS[35032] = Fluid3D([7538,7556,8110,8692],0); -ELEMENTS[35033] = Fluid3D([7457,8110,8372,7538],0); -ELEMENTS[35034] = Fluid3D([8372,8110,8692,8585],0); -ELEMENTS[35035] = Fluid3D([8110,8692,8585,7538],0); -ELEMENTS[35036] = Fluid3D([8372,8110,8585,7538],0); -ELEMENTS[35037] = Fluid3D([18009,17981,17798,17732],0); -ELEMENTS[35038] = Fluid3D([7994,7959,8056,8708],0); -ELEMENTS[35039] = Fluid3D([17451,17592,17475,17329],0); -ELEMENTS[35040] = Fluid3D([17592,17475,17329,17212],0); -ELEMENTS[35041] = Fluid3D([17451,17592,17329,17269],0); -ELEMENTS[35042] = Fluid3D([8303,7952,8663,7981],0); -ELEMENTS[35043] = Fluid3D([12950,13192,13580,14076],0); -ELEMENTS[35044] = Fluid3D([13192,13580,14076,13751],0); -ELEMENTS[35045] = Fluid3D([13192,13580,13751,13242],0); -ELEMENTS[35046] = Fluid3D([15267,15687,15572,16040],0); -ELEMENTS[35047] = Fluid3D([17902,18104,18181,18005],0); -ELEMENTS[35048] = Fluid3D([8096,8523,7728,8198],0); -ELEMENTS[35049] = Fluid3D([11863,11640,10919,11958],0); -ELEMENTS[35050] = Fluid3D([9317,8671,8545,8462],0); -ELEMENTS[35051] = Fluid3D([12678,12068,12080,12802],0); -ELEMENTS[35052] = Fluid3D([12068,12080,12802,12187],0); -ELEMENTS[35053] = Fluid3D([12734,12241,11874,11445],0); -ELEMENTS[35054] = Fluid3D([7668,8212,7722,7843],0); -ELEMENTS[35055] = Fluid3D([7668,8212,7843,7728],0); -ELEMENTS[35056] = Fluid3D([2606,2671,2420,2715],0); -ELEMENTS[35057] = Fluid3D([2606,2671,2715,2920],0); -ELEMENTS[35058] = Fluid3D([2671,2420,2715,2995],0); -ELEMENTS[35059] = Fluid3D([14949,14979,14361,14540],0); -ELEMENTS[35060] = Fluid3D([14361,14949,14540,14330],0); -ELEMENTS[35061] = Fluid3D([14361,14949,14330,14806],0); -ELEMENTS[35062] = Fluid3D([14949,14330,14806,14444],0); -ELEMENTS[35063] = Fluid3D([14540,14361,14330,13955],0); -ELEMENTS[35064] = Fluid3D([14949,14540,14330,14444],0); -ELEMENTS[35065] = Fluid3D([14979,14361,14540,14397],0); -ELEMENTS[35066] = Fluid3D([14949,14979,14540,15477],0); -ELEMENTS[35067] = Fluid3D([5091,4969,4934,5585],0); -ELEMENTS[35068] = Fluid3D([9034,9180,10027,9502],0); -ELEMENTS[35069] = Fluid3D([14358,13900,14039,14946],0); -ELEMENTS[35070] = Fluid3D([4206,4017,3829,4326],0); -ELEMENTS[35071] = Fluid3D([15079,14894,14461,15009],0); -ELEMENTS[35072] = Fluid3D([14894,14461,15009,15044],0); -ELEMENTS[35073] = Fluid3D([14461,15009,15044,14702],0); -ELEMENTS[35074] = Fluid3D([14894,14461,15044,14636],0); -ELEMENTS[35075] = Fluid3D([14461,15044,14636,14702],0); -ELEMENTS[35076] = Fluid3D([15044,14636,14702,15332],0); -ELEMENTS[35077] = Fluid3D([15044,14636,15332,15256],0); -ELEMENTS[35078] = Fluid3D([15044,14636,15256,14894],0); -ELEMENTS[35079] = Fluid3D([15332,15044,15256,15785],0); -ELEMENTS[35080] = Fluid3D([14636,15332,15256,15013],0); -ELEMENTS[35081] = Fluid3D([14636,14702,15332,15013],0); -ELEMENTS[35082] = Fluid3D([14702,15044,15332,15392],0); -ELEMENTS[35083] = Fluid3D([15044,15332,15392,15785],0); -ELEMENTS[35084] = Fluid3D([15332,15256,15013,15496],0); -ELEMENTS[35085] = Fluid3D([15332,15256,15496,15785],0); -ELEMENTS[35086] = Fluid3D([15256,15013,15496,14753],0); -ELEMENTS[35087] = Fluid3D([15496,15256,14753,14894],0); -ELEMENTS[35088] = Fluid3D([15256,14636,15013,14623],0); -ELEMENTS[35089] = Fluid3D([15256,14636,14623,14894],0); -ELEMENTS[35090] = Fluid3D([14636,15013,14623,14362],0); -ELEMENTS[35091] = Fluid3D([14623,14636,14362,14130],0); -ELEMENTS[35092] = Fluid3D([14623,14636,14130,13746],0); -ELEMENTS[35093] = Fluid3D([14636,14623,14894,14461],0); -ELEMENTS[35094] = Fluid3D([14636,14623,14461,13746],0); -ELEMENTS[35095] = Fluid3D([14623,14894,14461,14753],0); -ELEMENTS[35096] = Fluid3D([15013,14623,14362,14172],0); -ELEMENTS[35097] = Fluid3D([14636,15013,14362,14201],0); -ELEMENTS[35098] = Fluid3D([14130,14623,13746,13617],0); -ELEMENTS[35099] = Fluid3D([13746,14130,13617,13359],0); -ELEMENTS[35100] = Fluid3D([13746,14130,13359,14201],0); -ELEMENTS[35101] = Fluid3D([14130,13359,14201,13399],0); -ELEMENTS[35102] = Fluid3D([14130,13617,13359,13399],0); -ELEMENTS[35103] = Fluid3D([13746,14130,14201,14702],0); -ELEMENTS[35104] = Fluid3D([14130,14623,13617,14362],0); -ELEMENTS[35105] = Fluid3D([13617,13746,13359,12787],0); -ELEMENTS[35106] = Fluid3D([13746,14130,14702,14636],0); -ELEMENTS[35107] = Fluid3D([14130,14702,14636,14201],0); -ELEMENTS[35108] = Fluid3D([15496,15256,14894,15079],0); -ELEMENTS[35109] = Fluid3D([14702,15044,15392,15113],0); -ELEMENTS[35110] = Fluid3D([15044,15392,15113,15009],0); -ELEMENTS[35111] = Fluid3D([15392,14702,15113,14740],0); -ELEMENTS[35112] = Fluid3D([15113,15392,14740,15529],0); -ELEMENTS[35113] = Fluid3D([15044,15392,15009,15785],0); -ELEMENTS[35114] = Fluid3D([15009,14894,15044,15256],0); -ELEMENTS[35115] = Fluid3D([15044,15009,15256,15785],0); -ELEMENTS[35116] = Fluid3D([15332,14702,15392,15322],0); -ELEMENTS[35117] = Fluid3D([15392,15332,15322,16048],0); -ELEMENTS[35118] = Fluid3D([14623,15256,14894,14753],0); -ELEMENTS[35119] = Fluid3D([14623,15256,14753,15013],0); -ELEMENTS[35120] = Fluid3D([14623,14362,14172,13617],0); -ELEMENTS[35121] = Fluid3D([13617,13359,13399,12770],0); -ELEMENTS[35122] = Fluid3D([14702,15392,15322,14740],0); -ELEMENTS[35123] = Fluid3D([10514,10895,11593,10964],0); -ELEMENTS[35124] = Fluid3D([11957,12380,11177,11446],0); -ELEMENTS[35125] = Fluid3D([13871,14343,14576,14161],0); -ELEMENTS[35126] = Fluid3D([12542,12695,13148,13559],0); -ELEMENTS[35127] = Fluid3D([3357,3064,3114,3564],0); -ELEMENTS[35128] = Fluid3D([3357,3064,3564,3420],0); -ELEMENTS[35129] = Fluid3D([18031,18228,18195,18318],0); -ELEMENTS[35130] = Fluid3D([18228,18195,18318,18395],0); -ELEMENTS[35131] = Fluid3D([18228,18195,18395,18216],0); -ELEMENTS[35132] = Fluid3D([18195,18318,18395,18285],0); -ELEMENTS[35133] = Fluid3D([18318,18228,18395,18416],0); -ELEMENTS[35134] = Fluid3D([18395,18318,18416,18425],0); -ELEMENTS[35135] = Fluid3D([18395,18318,18425,18285],0); -ELEMENTS[35136] = Fluid3D([18318,18416,18425,18449],0); -ELEMENTS[35137] = Fluid3D([18425,18318,18449,18317],0); -ELEMENTS[35138] = Fluid3D([18425,18318,18317,18285],0); -ELEMENTS[35139] = Fluid3D([18416,18395,18425,18530],0); -ELEMENTS[35140] = Fluid3D([18395,18425,18530,18400],0); -ELEMENTS[35141] = Fluid3D([18395,18425,18400,18285],0); -ELEMENTS[35142] = Fluid3D([18416,18395,18530,18477],0); -ELEMENTS[35143] = Fluid3D([18530,18416,18477,18531],0); -ELEMENTS[35144] = Fluid3D([18416,18395,18477,18228],0); -ELEMENTS[35145] = Fluid3D([18318,18228,18416,18249],0); -ELEMENTS[35146] = Fluid3D([18416,18318,18249,18449],0); -ELEMENTS[35147] = Fluid3D([18195,18031,18318,18157],0); -ELEMENTS[35148] = Fluid3D([18031,18318,18157,18075],0); -ELEMENTS[35149] = Fluid3D([18195,18031,18157,17895],0); -ELEMENTS[35150] = Fluid3D([18318,18195,18157,18285],0); -ELEMENTS[35151] = Fluid3D([18195,18157,18285,18061],0); -ELEMENTS[35152] = Fluid3D([18157,18285,18061,18149],0); -ELEMENTS[35153] = Fluid3D([18157,18285,18149,18317],0); -ELEMENTS[35154] = Fluid3D([18157,18285,18317,18318],0); -ELEMENTS[35155] = Fluid3D([18149,18157,18317,18075],0); -ELEMENTS[35156] = Fluid3D([18285,18195,18061,18261],0); -ELEMENTS[35157] = Fluid3D([18317,18157,18318,18075],0); -ELEMENTS[35158] = Fluid3D([18195,18157,18061,17895],0); -ELEMENTS[35159] = Fluid3D([18157,18061,17895,18149],0); -ELEMENTS[35160] = Fluid3D([18228,18416,18249,18298],0); -ELEMENTS[35161] = Fluid3D([18228,18416,18298,18477],0); -ELEMENTS[35162] = Fluid3D([18416,18249,18298,18397],0); -ELEMENTS[35163] = Fluid3D([18249,18298,18397,18177],0); -ELEMENTS[35164] = Fluid3D([18298,18397,18177,18446],0); -ELEMENTS[35165] = Fluid3D([18249,18298,18177,18074],0); -ELEMENTS[35166] = Fluid3D([18298,18177,18074,18138],0); -ELEMENTS[35167] = Fluid3D([18177,18249,18074,17952],0); -ELEMENTS[35168] = Fluid3D([18074,18177,17952,17692],0); -ELEMENTS[35169] = Fluid3D([18249,18228,18298,18074],0); -ELEMENTS[35170] = Fluid3D([18298,18416,18397,18531],0); -ELEMENTS[35171] = Fluid3D([18416,18249,18397,18445],0); -ELEMENTS[35172] = Fluid3D([18416,18249,18445,18449],0); -ELEMENTS[35173] = Fluid3D([18397,18416,18445,18539],0); -ELEMENTS[35174] = Fluid3D([18249,18397,18445,18220],0); -ELEMENTS[35175] = Fluid3D([18397,18249,18177,18220],0); -ELEMENTS[35176] = Fluid3D([18318,18228,18249,18031],0); -ELEMENTS[35177] = Fluid3D([18031,18157,17895,18075],0); -ELEMENTS[35178] = Fluid3D([11694,11295,11056,11592],0); -ELEMENTS[35179] = Fluid3D([11694,11295,11592,12583],0); -ELEMENTS[35180] = Fluid3D([16669,17017,17228,17097],0); -ELEMENTS[35181] = Fluid3D([6969,6243,6900,6750],0); -ELEMENTS[35182] = Fluid3D([6969,6243,6750,6458],0); -ELEMENTS[35183] = Fluid3D([11433,11870,11124,11908],0); -ELEMENTS[35184] = Fluid3D([10404,11345,10653,10304],0); -ELEMENTS[35185] = Fluid3D([10653,10404,10304,9920],0); -ELEMENTS[35186] = Fluid3D([10404,11345,10304,10829],0); -ELEMENTS[35187] = Fluid3D([10304,10404,10829,9187],0); -ELEMENTS[35188] = Fluid3D([18096,17859,17813,18070],0); -ELEMENTS[35189] = Fluid3D([14704,14341,14625,15385],0); -ELEMENTS[35190] = Fluid3D([8249,7500,7461,8073],0); -ELEMENTS[35191] = Fluid3D([11621,12079,12803,12234],0); -ELEMENTS[35192] = Fluid3D([14220,13649,14112,13707],0); -ELEMENTS[35193] = Fluid3D([15833,16088,15849,16449],0); -ELEMENTS[35194] = Fluid3D([13684,13882,14085,13269],0); -ELEMENTS[35195] = Fluid3D([6228,6533,6979,6178],0); -ELEMENTS[35196] = Fluid3D([9424,8752,9384,9040],0); -ELEMENTS[35197] = Fluid3D([6514,6149,6811,6535],0); -ELEMENTS[35198] = Fluid3D([15999,16231,15780,15871],0); -ELEMENTS[35199] = Fluid3D([5759,6210,5613,5804],0); -ELEMENTS[35200] = Fluid3D([6372,6317,5733,6532],0); -ELEMENTS[35201] = Fluid3D([11784,11402,12329,11826],0); -ELEMENTS[35202] = Fluid3D([13281,12709,13048,13252],0); -ELEMENTS[35203] = Fluid3D([15238,14747,14640,15219],0); -ELEMENTS[35204] = Fluid3D([16259,16314,16343,15886],0); -ELEMENTS[35205] = Fluid3D([16259,16314,15886,15774],0); -ELEMENTS[35206] = Fluid3D([16343,16259,15886,15896],0); -ELEMENTS[35207] = Fluid3D([6268,7027,6313,6119],0); -ELEMENTS[35208] = Fluid3D([6313,6268,6119,5807],0); -ELEMENTS[35209] = Fluid3D([13545,12801,12681,13775],0); -ELEMENTS[35210] = Fluid3D([10975,10823,9871,10662],0); -ELEMENTS[35211] = Fluid3D([10975,10823,10662,11600],0); -ELEMENTS[35212] = Fluid3D([10407,9911,9261,10479],0); -ELEMENTS[35213] = Fluid3D([14897,15267,15576,15462],0); -ELEMENTS[35214] = Fluid3D([16246,16000,16340,16513],0); -ELEMENTS[35215] = Fluid3D([2566,2653,2482,2800],0); -ELEMENTS[35216] = Fluid3D([2482,2566,2800,2602],0); -ELEMENTS[35217] = Fluid3D([2653,2482,2800,2739],0); -ELEMENTS[35218] = Fluid3D([6165,6143,5584,5846],0); -ELEMENTS[35219] = Fluid3D([6143,5584,5846,5338],0); -ELEMENTS[35220] = Fluid3D([17362,17708,17335,17349],0); -ELEMENTS[35221] = Fluid3D([14287,13599,14351,13622],0); -ELEMENTS[35222] = Fluid3D([8977,8395,8505,8880],0); -ELEMENTS[35223] = Fluid3D([8977,8395,8880,9389],0); -ELEMENTS[35224] = Fluid3D([8977,8395,9389,8580],0); -ELEMENTS[35225] = Fluid3D([8395,8505,8880,7818],0); -ELEMENTS[35226] = Fluid3D([17050,17202,17498,17330],0); -ELEMENTS[35227] = Fluid3D([17050,17202,17330,17016],0); -ELEMENTS[35228] = Fluid3D([13953,14097,13716,13101],0); -ELEMENTS[35229] = Fluid3D([14097,13716,13101,13001],0); -ELEMENTS[35230] = Fluid3D([13732,12875,12712,13275],0); -ELEMENTS[35231] = Fluid3D([11350,11848,12504,12237],0); -ELEMENTS[35232] = Fluid3D([11350,11848,12237,11233],0); -ELEMENTS[35233] = Fluid3D([15442,15220,15312,14706],0); -ELEMENTS[35234] = Fluid3D([14591,14555,14111,14648],0); -ELEMENTS[35235] = Fluid3D([14111,14591,14648,14068],0); -ELEMENTS[35236] = Fluid3D([4518,4727,4388,4924],0); -ELEMENTS[35237] = Fluid3D([2593,2610,2480,2932],0); -ELEMENTS[35238] = Fluid3D([4144,3994,4461,4448],0); -ELEMENTS[35239] = Fluid3D([16108,15647,15900,16067],0); -ELEMENTS[35240] = Fluid3D([5753,5784,5285,5347],0); -ELEMENTS[35241] = Fluid3D([10187,11037,11203,11120],0); -ELEMENTS[35242] = Fluid3D([10187,11037,11120,10440],0); -ELEMENTS[35243] = Fluid3D([17114,16992,16831,16567],0); -ELEMENTS[35244] = Fluid3D([15111,14932,14252,15337],0); -ELEMENTS[35245] = Fluid3D([13001,12611,12298,13277],0); -ELEMENTS[35246] = Fluid3D([12298,13001,13277,13433],0); -ELEMENTS[35247] = Fluid3D([13001,12611,13277,13261],0); -ELEMENTS[35248] = Fluid3D([8437,9329,9384,9040],0); -ELEMENTS[35249] = Fluid3D([17779,17993,18055,18039],0); -ELEMENTS[35250] = Fluid3D([18055,17779,18039,17924],0); -ELEMENTS[35251] = Fluid3D([18055,17779,17924,17848],0); -ELEMENTS[35252] = Fluid3D([18055,17779,17848,17773],0); -ELEMENTS[35253] = Fluid3D([12373,11672,11715,11088],0); -ELEMENTS[35254] = Fluid3D([15128,14673,14645,15155],0); -ELEMENTS[35255] = Fluid3D([15128,14673,15155,15384],0); -ELEMENTS[35256] = Fluid3D([3510,3417,3638,3189],0); -ELEMENTS[35257] = Fluid3D([13854,14627,14008,13654],0); -ELEMENTS[35258] = Fluid3D([4951,5183,5381,5186],0); -ELEMENTS[35259] = Fluid3D([5381,4951,5186,5292],0); -ELEMENTS[35260] = Fluid3D([10076,10495,10990,10640],0); -ELEMENTS[35261] = Fluid3D([16661,16231,16456,16591],0); -ELEMENTS[35262] = Fluid3D([4694,5279,5091,4918],0); -ELEMENTS[35263] = Fluid3D([9493,9638,10145,9067],0); -ELEMENTS[35264] = Fluid3D([9493,9638,9067,8727],0); -ELEMENTS[35265] = Fluid3D([9067,9493,8727,9357],0); -ELEMENTS[35266] = Fluid3D([12758,13214,12913,13318],0); -ELEMENTS[35267] = Fluid3D([13214,12913,13318,13919],0); -ELEMENTS[35268] = Fluid3D([12913,13318,13919,12869],0); -ELEMENTS[35269] = Fluid3D([12913,12758,13318,12023],0); -ELEMENTS[35270] = Fluid3D([13214,12913,13919,13035],0); -ELEMENTS[35271] = Fluid3D([13214,12913,13035,11989],0); -ELEMENTS[35272] = Fluid3D([7482,7409,7520,8341],0); -ELEMENTS[35273] = Fluid3D([6244,6646,6450,6996],0); -ELEMENTS[35274] = Fluid3D([15412,15958,15592,15598],0); -ELEMENTS[35275] = Fluid3D([15081,15644,15634,15563],0); -ELEMENTS[35276] = Fluid3D([15634,15081,15563,15144],0); -ELEMENTS[35277] = Fluid3D([15644,15634,15563,16207],0); -ELEMENTS[35278] = Fluid3D([12258,12011,12288,13136],0); -ELEMENTS[35279] = Fluid3D([3768,3517,3355,3191],0); -ELEMENTS[35280] = Fluid3D([6159,6722,6333,6080],0); -ELEMENTS[35281] = Fluid3D([12857,13365,12430,13301],0); -ELEMENTS[35282] = Fluid3D([6295,5710,6767,6363],0); -ELEMENTS[35283] = Fluid3D([6767,6295,6363,6839],0); -ELEMENTS[35284] = Fluid3D([9321,8668,8968,8915],0); -ELEMENTS[35285] = Fluid3D([3668,3671,3642,3480],0); -ELEMENTS[35286] = Fluid3D([3671,3642,3480,3214],0); -ELEMENTS[35287] = Fluid3D([15104,15685,15435,15769],0); -ELEMENTS[35288] = Fluid3D([15104,15685,15769,15518],0); -ELEMENTS[35289] = Fluid3D([5609,5732,5416,6215],0); -ELEMENTS[35290] = Fluid3D([7014,6599,6552,5866],0); -ELEMENTS[35291] = Fluid3D([4630,4311,4899,4408],0); -ELEMENTS[35292] = Fluid3D([5223,4870,4585,4451],0); -ELEMENTS[35293] = Fluid3D([5223,4870,4451,4650],0); -ELEMENTS[35294] = Fluid3D([4870,4451,4650,4752],0); -ELEMENTS[35295] = Fluid3D([17141,16950,17430,17187],0); -ELEMENTS[35296] = Fluid3D([17430,17141,17187,17626],0); -ELEMENTS[35297] = Fluid3D([17141,16950,17187,16619],0); -ELEMENTS[35298] = Fluid3D([7450,7872,7225,6923],0); -ELEMENTS[35299] = Fluid3D([17602,17337,17227,17721],0); -ELEMENTS[35300] = Fluid3D([5669,6106,5932,5543],0); -ELEMENTS[35301] = Fluid3D([3201,3260,2952,2949],0); -ELEMENTS[35302] = Fluid3D([2952,3201,2949,3172],0); -ELEMENTS[35303] = Fluid3D([16646,16779,16802,16197],0); -ELEMENTS[35304] = Fluid3D([6617,6776,6305,6038],0); -ELEMENTS[35305] = Fluid3D([3123,2868,2946,2739],0); -ELEMENTS[35306] = Fluid3D([2868,2946,2739,2592],0); -ELEMENTS[35307] = Fluid3D([2868,2946,2592,2794],0); -ELEMENTS[35308] = Fluid3D([2868,2946,2794,3181],0); -ELEMENTS[35309] = Fluid3D([2592,2868,2794,2638],0); -ELEMENTS[35310] = Fluid3D([2868,2794,2638,2913],0); -ELEMENTS[35311] = Fluid3D([2868,2794,2913,3181],0); -ELEMENTS[35312] = Fluid3D([18024,17930,17995,17747],0); -ELEMENTS[35313] = Fluid3D([17995,18024,17747,18069],0); -ELEMENTS[35314] = Fluid3D([17995,18024,18069,18252],0); -ELEMENTS[35315] = Fluid3D([18024,17747,18069,18098],0); -ELEMENTS[35316] = Fluid3D([18069,18024,18098,18287],0); -ELEMENTS[35317] = Fluid3D([18069,18024,18287,18252],0); -ELEMENTS[35318] = Fluid3D([12611,12140,11532,12334],0); -ELEMENTS[35319] = Fluid3D([10218,10434,10579,11386],0); -ELEMENTS[35320] = Fluid3D([18001,17700,17939,18005],0); -ELEMENTS[35321] = Fluid3D([13339,14089,13596,14208],0); -ELEMENTS[35322] = Fluid3D([12459,12480,12105,11359],0); -ELEMENTS[35323] = Fluid3D([7934,8580,8212,9063],0); -ELEMENTS[35324] = Fluid3D([2512,2240,2340,2410],0); -ELEMENTS[35325] = Fluid3D([15702,15520,15477,14979],0); -ELEMENTS[35326] = Fluid3D([5889,5279,5673,5402],0); -ELEMENTS[35327] = Fluid3D([13442,13317,13985,13914],0); -ELEMENTS[35328] = Fluid3D([14416,14671,15172,14641],0); -ELEMENTS[35329] = Fluid3D([11699,12093,12804,11708],0); -ELEMENTS[35330] = Fluid3D([7364,7699,7581,6835],0); -ELEMENTS[35331] = Fluid3D([13027,12591,12442,12394],0); -ELEMENTS[35332] = Fluid3D([15371,14963,15003,14976],0); -ELEMENTS[35333] = Fluid3D([9430,9373,9156,8424],0); -ELEMENTS[35334] = Fluid3D([9373,9156,8424,9083],0); -ELEMENTS[35335] = Fluid3D([4331,3906,4335,3832],0); -ELEMENTS[35336] = Fluid3D([12304,12404,13116,12676],0); -ELEMENTS[35337] = Fluid3D([17795,17768,17952,17613],0); -ELEMENTS[35338] = Fluid3D([17768,17952,17613,17692],0); -ELEMENTS[35339] = Fluid3D([17952,17795,17613,17868],0); -ELEMENTS[35340] = Fluid3D([17795,17768,17613,17437],0); -ELEMENTS[35341] = Fluid3D([17438,17344,17448,17157],0); -ELEMENTS[35342] = Fluid3D([14011,14693,14548,15015],0); -ELEMENTS[35343] = Fluid3D([10791,11383,11878,11619],0); -ELEMENTS[35344] = Fluid3D([17116,17448,17253,17001],0); -ELEMENTS[35345] = Fluid3D([12051,11230,11016,12055],0); -ELEMENTS[35346] = Fluid3D([14651,14248,14498,15112],0); -ELEMENTS[35347] = Fluid3D([16131,16528,16648,16544],0); -ELEMENTS[35348] = Fluid3D([8216,8547,8281,7608],0); -ELEMENTS[35349] = Fluid3D([17001,16727,17020,16505],0); -ELEMENTS[35350] = Fluid3D([15220,15684,14982,14968],0); -ELEMENTS[35351] = Fluid3D([15684,14982,14968,15494],0); -ELEMENTS[35352] = Fluid3D([15684,14982,15494,15706],0); -ELEMENTS[35353] = Fluid3D([14982,14968,15494,15153],0); -ELEMENTS[35354] = Fluid3D([15494,14982,15153,15706],0); -ELEMENTS[35355] = Fluid3D([15153,15494,15706,15169],0); -ELEMENTS[35356] = Fluid3D([13072,13777,12995,12979],0); -ELEMENTS[35357] = Fluid3D([11217,11166,10302,10405],0); -ELEMENTS[35358] = Fluid3D([10302,11217,10405,10907],0); -ELEMENTS[35359] = Fluid3D([11166,10302,10405,10637],0); -ELEMENTS[35360] = Fluid3D([10302,10405,10637,9811],0); -ELEMENTS[35361] = Fluid3D([10405,10637,9811,9835],0); -ELEMENTS[35362] = Fluid3D([10302,10405,9811,9553],0); -ELEMENTS[35363] = Fluid3D([10302,10405,9553,9992],0); -ELEMENTS[35364] = Fluid3D([5119,4942,4600,5178],0); -ELEMENTS[35365] = Fluid3D([5119,4942,5178,5383],0); -ELEMENTS[35366] = Fluid3D([4942,5178,5383,4797],0); -ELEMENTS[35367] = Fluid3D([5383,4942,4797,5035],0); -ELEMENTS[35368] = Fluid3D([4942,5178,4797,4600],0); -ELEMENTS[35369] = Fluid3D([4942,4797,5035,4422],0); -ELEMENTS[35370] = Fluid3D([4942,4797,4422,4600],0); -ELEMENTS[35371] = Fluid3D([5383,4942,5035,5220],0); -ELEMENTS[35372] = Fluid3D([9363,9362,9801,10800],0); -ELEMENTS[35373] = Fluid3D([5438,6084,5665,5549],0); -ELEMENTS[35374] = Fluid3D([6657,6200,6112,5648],0); -ELEMENTS[35375] = Fluid3D([4268,4601,4204,3988],0); -ELEMENTS[35376] = Fluid3D([11291,11784,12225,11826],0); -ELEMENTS[35377] = Fluid3D([16205,16473,16232,16761],0); -ELEMENTS[35378] = Fluid3D([16257,16589,15992,16602],0); -ELEMENTS[35379] = Fluid3D([14329,14584,15029,14551],0); -ELEMENTS[35380] = Fluid3D([4453,4851,4380,4291],0); -ELEMENTS[35381] = Fluid3D([3285,3041,3050,2859],0); -ELEMENTS[35382] = Fluid3D([10022,10550,10549,9443],0); -ELEMENTS[35383] = Fluid3D([4312,3961,3995,4437],0); -ELEMENTS[35384] = Fluid3D([6871,6278,6299,5778],0); -ELEMENTS[35385] = Fluid3D([6278,6299,5778,6008],0); -ELEMENTS[35386] = Fluid3D([8195,8218,8645,7639],0); -ELEMENTS[35387] = Fluid3D([17843,17601,17692,18036],0); -ELEMENTS[35388] = Fluid3D([15961,16213,16428,16438],0); -ELEMENTS[35389] = Fluid3D([15961,16213,16438,16623],0); -ELEMENTS[35390] = Fluid3D([16506,16324,16554,16065],0); -ELEMENTS[35391] = Fluid3D([16506,16324,16065,16367],0); -ELEMENTS[35392] = Fluid3D([16554,16506,16065,16390],0); -ELEMENTS[35393] = Fluid3D([16554,16506,16390,16944],0); -ELEMENTS[35394] = Fluid3D([16324,16554,16065,16116],0); -ELEMENTS[35395] = Fluid3D([16065,16554,16390,16116],0); -ELEMENTS[35396] = Fluid3D([16390,16554,16944,16832],0); -ELEMENTS[35397] = Fluid3D([16390,16554,16832,16276],0); -ELEMENTS[35398] = Fluid3D([16390,16554,16276,16116],0); -ELEMENTS[35399] = Fluid3D([11144,11684,10486,10721],0); -ELEMENTS[35400] = Fluid3D([11144,11684,10721,11472],0); -ELEMENTS[35401] = Fluid3D([11144,11684,11472,12399],0); -ELEMENTS[35402] = Fluid3D([16069,15942,16465,16297],0); -ELEMENTS[35403] = Fluid3D([15942,16465,16297,16252],0); -ELEMENTS[35404] = Fluid3D([15942,16465,16252,15622],0); -ELEMENTS[35405] = Fluid3D([16297,15942,16252,15847],0); -ELEMENTS[35406] = Fluid3D([15942,16252,15847,15473],0); -ELEMENTS[35407] = Fluid3D([16297,15942,15847,15517],0); -ELEMENTS[35408] = Fluid3D([15847,15942,15473,15517],0); -ELEMENTS[35409] = Fluid3D([18551,18472,18583,18591],0); -ELEMENTS[35410] = Fluid3D([14366,14639,14596,13578],0); -ELEMENTS[35411] = Fluid3D([13485,13044,13928,13494],0); -ELEMENTS[35412] = Fluid3D([11766,11058,10912,12223],0); -ELEMENTS[35413] = Fluid3D([8966,9929,9839,9576],0); -ELEMENTS[35414] = Fluid3D([9929,9839,9576,10870],0); -ELEMENTS[35415] = Fluid3D([8966,9929,9576,9514],0); -ELEMENTS[35416] = Fluid3D([15768,15836,16147,16368],0); -ELEMENTS[35417] = Fluid3D([18125,18144,18102,18351],0); -ELEMENTS[35418] = Fluid3D([6723,6415,6667,7461],0); -ELEMENTS[35419] = Fluid3D([5670,5208,5320,5495],0); -ELEMENTS[35420] = Fluid3D([5208,5320,5495,4933],0); -ELEMENTS[35421] = Fluid3D([5208,5320,4933,4556],0); -ELEMENTS[35422] = Fluid3D([5495,5208,4933,5242],0); -ELEMENTS[35423] = Fluid3D([4933,5495,5242,5434],0); -ELEMENTS[35424] = Fluid3D([5242,4933,5434,4878],0); -ELEMENTS[35425] = Fluid3D([5434,5242,4878,5113],0); -ELEMENTS[35426] = Fluid3D([5242,4933,4878,4821],0); -ELEMENTS[35427] = Fluid3D([5242,4933,4821,5208],0); -ELEMENTS[35428] = Fluid3D([5495,5242,5434,6024],0); -ELEMENTS[35429] = Fluid3D([5242,4878,5113,4711],0); -ELEMENTS[35430] = Fluid3D([4878,5113,4711,4528],0); -ELEMENTS[35431] = Fluid3D([4878,5113,4528,4944],0); -ELEMENTS[35432] = Fluid3D([5320,5495,4933,4713],0); -ELEMENTS[35433] = Fluid3D([4933,5320,4713,4556],0); -ELEMENTS[35434] = Fluid3D([4713,4933,4556,4407],0); -ELEMENTS[35435] = Fluid3D([4878,5113,4944,5434],0); -ELEMENTS[35436] = Fluid3D([4944,4878,5434,4713],0); -ELEMENTS[35437] = Fluid3D([4933,5208,4556,4821],0); -ELEMENTS[35438] = Fluid3D([4556,4933,4821,4407],0); -ELEMENTS[35439] = Fluid3D([4713,4933,4407,4878],0); -ELEMENTS[35440] = Fluid3D([5242,5434,6024,5751],0); -ELEMENTS[35441] = Fluid3D([4711,4878,4528,4407],0); -ELEMENTS[35442] = Fluid3D([4933,4407,4878,4821],0); -ELEMENTS[35443] = Fluid3D([4713,4933,4878,5434],0); -ELEMENTS[35444] = Fluid3D([15653,16194,15565,15550],0); -ELEMENTS[35445] = Fluid3D([15565,15653,15550,15021],0); -ELEMENTS[35446] = Fluid3D([15550,15565,15021,15033],0); -ELEMENTS[35447] = Fluid3D([15021,15550,15033,15145],0); -ELEMENTS[35448] = Fluid3D([15653,15550,15021,15145],0); -ELEMENTS[35449] = Fluid3D([14886,14301,14998,14031],0); -ELEMENTS[35450] = Fluid3D([12909,12429,12464,12540],0); -ELEMENTS[35451] = Fluid3D([16831,16992,16924,16435],0); -ELEMENTS[35452] = Fluid3D([16992,16924,16435,16643],0); -ELEMENTS[35453] = Fluid3D([16992,16924,16643,17023],0); -ELEMENTS[35454] = Fluid3D([16992,16924,17023,17355],0); -ELEMENTS[35455] = Fluid3D([16924,16643,17023,17210],0); -ELEMENTS[35456] = Fluid3D([16924,16435,16643,16330],0); -ELEMENTS[35457] = Fluid3D([16643,16924,16330,16816],0); -ELEMENTS[35458] = Fluid3D([16924,16435,16330,16162],0); -ELEMENTS[35459] = Fluid3D([16435,16330,16162,15914],0); -ELEMENTS[35460] = Fluid3D([16330,16643,16816,16418],0); -ELEMENTS[35461] = Fluid3D([16643,16816,16418,16842],0); -ELEMENTS[35462] = Fluid3D([16816,16418,16842,16873],0); -ELEMENTS[35463] = Fluid3D([16842,16816,16873,17210],0); -ELEMENTS[35464] = Fluid3D([16842,16816,17210,16643],0); -ELEMENTS[35465] = Fluid3D([16816,16873,17210,17101],0); -ELEMENTS[35466] = Fluid3D([17210,16816,17101,16924],0); -ELEMENTS[35467] = Fluid3D([16816,16873,17101,16957],0); -ELEMENTS[35468] = Fluid3D([17101,16816,16957,16605],0); -ELEMENTS[35469] = Fluid3D([17101,16816,16605,16924],0); -ELEMENTS[35470] = Fluid3D([16816,16605,16924,16330],0); -ELEMENTS[35471] = Fluid3D([16816,16605,16330,16418],0); -ELEMENTS[35472] = Fluid3D([16605,16924,16330,16162],0); -ELEMENTS[35473] = Fluid3D([16330,16605,16162,15767],0); -ELEMENTS[35474] = Fluid3D([16605,16330,16418,16251],0); -ELEMENTS[35475] = Fluid3D([16873,17101,16957,17446],0); -ELEMENTS[35476] = Fluid3D([16957,17101,16605,16839],0); -ELEMENTS[35477] = Fluid3D([16418,16643,16842,16740],0); -ELEMENTS[35478] = Fluid3D([16643,16842,16740,17210],0); -ELEMENTS[35479] = Fluid3D([16924,16831,16435,16658],0); -ELEMENTS[35480] = Fluid3D([16330,16643,16418,15914],0); -ELEMENTS[35481] = Fluid3D([16435,16992,16643,16377],0); -ELEMENTS[35482] = Fluid3D([16992,16643,16377,16740],0); -ELEMENTS[35483] = Fluid3D([16643,16377,16740,16234],0); -ELEMENTS[35484] = Fluid3D([16740,16643,16234,16418],0); -ELEMENTS[35485] = Fluid3D([16643,16234,16418,15914],0); -ELEMENTS[35486] = Fluid3D([16643,16377,16234,15914],0); -ELEMENTS[35487] = Fluid3D([16435,16992,16377,16567],0); -ELEMENTS[35488] = Fluid3D([16992,16643,16740,17023],0); -ELEMENTS[35489] = Fluid3D([16643,16740,17023,17210],0); -ELEMENTS[35490] = Fluid3D([16643,16435,16377,15914],0); -ELEMENTS[35491] = Fluid3D([16643,16924,16816,17210],0); -ELEMENTS[35492] = Fluid3D([16435,16643,16330,15914],0); -ELEMENTS[35493] = Fluid3D([16831,16992,16435,16567],0); -ELEMENTS[35494] = Fluid3D([17564,17638,17590,17889],0); -ELEMENTS[35495] = Fluid3D([15580,15524,15829,14821],0); -ELEMENTS[35496] = Fluid3D([12295,12544,11775,11419],0); -ELEMENTS[35497] = Fluid3D([7572,8683,8398,8246],0); -ELEMENTS[35498] = Fluid3D([13854,14429,14627,13973],0); -ELEMENTS[35499] = Fluid3D([3520,3510,3743,4057],0); -ELEMENTS[35500] = Fluid3D([8502,9008,8067,8743],0); -ELEMENTS[35501] = Fluid3D([4755,5265,4997,4817],0); -ELEMENTS[35502] = Fluid3D([3157,3560,3442,3528],0); -ELEMENTS[35503] = Fluid3D([18297,18148,18219,18178],0); -ELEMENTS[35504] = Fluid3D([18297,18148,18178,18347],0); -ELEMENTS[35505] = Fluid3D([16620,16510,16783,16032],0); -ELEMENTS[35506] = Fluid3D([16254,16543,16536,16711],0); -ELEMENTS[35507] = Fluid3D([16254,16543,16711,16606],0); -ELEMENTS[35508] = Fluid3D([16543,16536,16711,16887],0); -ELEMENTS[35509] = Fluid3D([16543,16536,16887,16730],0); -ELEMENTS[35510] = Fluid3D([16711,16543,16887,17034],0); -ELEMENTS[35511] = Fluid3D([16919,17036,16572,16652],0); -ELEMENTS[35512] = Fluid3D([16572,16919,16652,16347],0); -ELEMENTS[35513] = Fluid3D([16572,16919,16347,16436],0); -ELEMENTS[35514] = Fluid3D([16919,16652,16347,16852],0); -ELEMENTS[35515] = Fluid3D([16347,16919,16852,16436],0); -ELEMENTS[35516] = Fluid3D([16919,17036,16652,17067],0); -ELEMENTS[35517] = Fluid3D([16652,16572,16347,16311],0); -ELEMENTS[35518] = Fluid3D([16652,16572,16311,17036],0); -ELEMENTS[35519] = Fluid3D([14749,14469,15022,15346],0); -ELEMENTS[35520] = Fluid3D([14749,14469,15346,14613],0); -ELEMENTS[35521] = Fluid3D([15425,14506,15024,15390],0); -ELEMENTS[35522] = Fluid3D([7088,7120,7929,6890],0); -ELEMENTS[35523] = Fluid3D([3651,3517,3768,3386],0); -ELEMENTS[35524] = Fluid3D([5634,6120,5632,5406],0); -ELEMENTS[35525] = Fluid3D([5632,5634,5406,4958],0); -ELEMENTS[35526] = Fluid3D([5406,5632,4958,5049],0); -ELEMENTS[35527] = Fluid3D([5406,5632,5049,5545],0); -ELEMENTS[35528] = Fluid3D([8181,7961,8567,9206],0); -ELEMENTS[35529] = Fluid3D([8567,8181,9206,8976],0); -ELEMENTS[35530] = Fluid3D([8449,8363,9254,8713],0); -ELEMENTS[35531] = Fluid3D([14356,15038,14365,14711],0); -ELEMENTS[35532] = Fluid3D([7030,6624,6097,6483],0); -ELEMENTS[35533] = Fluid3D([16178,16187,16159,16727],0); -ELEMENTS[35534] = Fluid3D([16178,16187,16727,16560],0); -ELEMENTS[35535] = Fluid3D([16178,16187,16560,15840],0); -ELEMENTS[35536] = Fluid3D([14265,14055,13399,13892],0); -ELEMENTS[35537] = Fluid3D([6526,6218,5719,6113],0); -ELEMENTS[35538] = Fluid3D([6526,6218,6113,6341],0); -ELEMENTS[35539] = Fluid3D([5719,6526,6113,6718],0); -ELEMENTS[35540] = Fluid3D([2875,3162,3188,3343],0); -ELEMENTS[35541] = Fluid3D([4136,3978,4380,3772],0); -ELEMENTS[35542] = Fluid3D([3156,2860,3009,2636],0); -ELEMENTS[35543] = Fluid3D([6664,7010,6516,7329],0); -ELEMENTS[35544] = Fluid3D([16855,17007,17022,16488],0); -ELEMENTS[35545] = Fluid3D([16400,16545,16451,16922],0); -ELEMENTS[35546] = Fluid3D([12620,13430,12563,13286],0); -ELEMENTS[35547] = Fluid3D([12563,12620,13286,12286],0); -ELEMENTS[35548] = Fluid3D([12563,12620,12286,11526],0); -ELEMENTS[35549] = Fluid3D([14592,14672,15315,14809],0); -ELEMENTS[35550] = Fluid3D([6814,6737,7259,6642],0); -ELEMENTS[35551] = Fluid3D([17709,17898,18028,17797],0); -ELEMENTS[35552] = Fluid3D([17709,17898,17797,17654],0); -ELEMENTS[35553] = Fluid3D([14818,15465,15400,15089],0); -ELEMENTS[35554] = Fluid3D([15400,14818,15089,14406],0); -ELEMENTS[35555] = Fluid3D([14818,15465,15089,14875],0); -ELEMENTS[35556] = Fluid3D([14818,15089,14406,14875],0); -ELEMENTS[35557] = Fluid3D([15089,14406,14875,15211],0); -ELEMENTS[35558] = Fluid3D([15089,14406,15211,15400],0); -ELEMENTS[35559] = Fluid3D([15211,15089,15400,15465],0); -ELEMENTS[35560] = Fluid3D([15211,15089,15465,14875],0); -ELEMENTS[35561] = Fluid3D([18691,18671,18693,18692],0); -ELEMENTS[35562] = Fluid3D([9569,10017,10538,10235],0); -ELEMENTS[35563] = Fluid3D([9569,10017,10235,9505],0); -ELEMENTS[35564] = Fluid3D([9569,10017,9505,8936],0); -ELEMENTS[35565] = Fluid3D([10017,10235,9505,10670],0); -ELEMENTS[35566] = Fluid3D([8693,8001,8580,8212],0); -ELEMENTS[35567] = Fluid3D([8659,8956,9309,9884],0); -ELEMENTS[35568] = Fluid3D([9365,9952,9220,8605],0); -ELEMENTS[35569] = Fluid3D([6997,7784,6901,6899],0); -ELEMENTS[35570] = Fluid3D([2620,2410,2555,2250],0); -ELEMENTS[35571] = Fluid3D([4935,4775,4883,4334],0); -ELEMENTS[35572] = Fluid3D([12039,11034,11444,11306],0); -ELEMENTS[35573] = Fluid3D([11034,11444,11306,10538],0); -ELEMENTS[35574] = Fluid3D([11444,11306,10538,11421],0); -ELEMENTS[35575] = Fluid3D([11306,10538,11421,11109],0); -ELEMENTS[35576] = Fluid3D([11306,10538,11109,10235],0); -ELEMENTS[35577] = Fluid3D([11421,11306,11109,12065],0); -ELEMENTS[35578] = Fluid3D([11444,11306,11421,12196],0); -ELEMENTS[35579] = Fluid3D([11306,11421,12196,12065],0); -ELEMENTS[35580] = Fluid3D([11421,12196,12065,12466],0); -ELEMENTS[35581] = Fluid3D([11444,11306,12196,12039],0); -ELEMENTS[35582] = Fluid3D([11306,12196,12039,12218],0); -ELEMENTS[35583] = Fluid3D([12196,11444,12039,12519],0); -ELEMENTS[35584] = Fluid3D([12196,12039,12218,13244],0); -ELEMENTS[35585] = Fluid3D([14812,15039,14222,14625],0); -ELEMENTS[35586] = Fluid3D([15039,14222,14625,14604],0); -ELEMENTS[35587] = Fluid3D([6657,6492,7429,6576],0); -ELEMENTS[35588] = Fluid3D([6492,7429,6576,7187],0); -ELEMENTS[35589] = Fluid3D([11134,12267,11764,11747],0); -ELEMENTS[35590] = Fluid3D([11764,11134,11747,11241],0); -ELEMENTS[35591] = Fluid3D([11134,11747,11241,10524],0); -ELEMENTS[35592] = Fluid3D([11134,12267,11747,11772],0); -ELEMENTS[35593] = Fluid3D([11747,11134,11772,11613],0); -ELEMENTS[35594] = Fluid3D([9415,9208,9509,8414],0); -ELEMENTS[35595] = Fluid3D([7566,7055,6650,6540],0); -ELEMENTS[35596] = Fluid3D([7055,6650,6540,6254],0); -ELEMENTS[35597] = Fluid3D([16283,16351,16434,16718],0); -ELEMENTS[35598] = Fluid3D([12304,11864,11745,12676],0); -ELEMENTS[35599] = Fluid3D([12505,11820,11364,11900],0); -ELEMENTS[35600] = Fluid3D([4958,4620,4428,4596],0); -ELEMENTS[35601] = Fluid3D([12742,11972,11807,12218],0); -ELEMENTS[35602] = Fluid3D([4359,4326,3982,3826],0); -ELEMENTS[35603] = Fluid3D([12051,12129,11918,12745],0); -ELEMENTS[35604] = Fluid3D([11918,12051,12745,12055],0); -ELEMENTS[35605] = Fluid3D([12745,11918,12055,12128],0); -ELEMENTS[35606] = Fluid3D([6403,7013,7068,6922],0); -ELEMENTS[35607] = Fluid3D([6403,7013,6922,6827],0); -ELEMENTS[35608] = Fluid3D([6922,6403,6827,6205],0); -ELEMENTS[35609] = Fluid3D([6922,6403,6205,6065],0); -ELEMENTS[35610] = Fluid3D([6403,6205,6065,5593],0); -ELEMENTS[35611] = Fluid3D([6922,6403,6065,7068],0); -ELEMENTS[35612] = Fluid3D([7013,7068,6922,7700],0); -ELEMENTS[35613] = Fluid3D([7013,7068,7700,7679],0); -ELEMENTS[35614] = Fluid3D([6403,6827,6205,5707],0); -ELEMENTS[35615] = Fluid3D([7068,6922,7700,7044],0); -ELEMENTS[35616] = Fluid3D([7013,7068,7679,7211],0); -ELEMENTS[35617] = Fluid3D([5576,5509,5188,6131],0); -ELEMENTS[35618] = Fluid3D([17805,17965,17855,17789],0); -ELEMENTS[35619] = Fluid3D([3782,3420,3699,3873],0); -ELEMENTS[35620] = Fluid3D([3782,3420,3873,3659],0); -ELEMENTS[35621] = Fluid3D([15232,15864,15797,15735],0); -ELEMENTS[35622] = Fluid3D([15232,15864,15735,15385],0); -ELEMENTS[35623] = Fluid3D([15864,15735,15385,16032],0); -ELEMENTS[35624] = Fluid3D([15864,15797,15735,16217],0); -ELEMENTS[35625] = Fluid3D([18375,18294,18479,18410],0); -ELEMENTS[35626] = Fluid3D([14809,14629,15228,14310],0); -ELEMENTS[35627] = Fluid3D([15359,14757,14355,15072],0); -ELEMENTS[35628] = Fluid3D([10576,10449,10753,11059],0); -ELEMENTS[35629] = Fluid3D([10576,10449,11059,9914],0); -ELEMENTS[35630] = Fluid3D([10449,10753,11059,10752],0); -ELEMENTS[35631] = Fluid3D([6859,6755,6333,6250],0); -ELEMENTS[35632] = Fluid3D([6894,6228,6979,7161],0); -ELEMENTS[35633] = Fluid3D([14576,14048,14161,14922],0); -ELEMENTS[35634] = Fluid3D([14161,14576,14922,14720],0); -ELEMENTS[35635] = Fluid3D([14576,14048,14922,14660],0); -ELEMENTS[35636] = Fluid3D([4055,4282,4584,4655],0); -ELEMENTS[35637] = Fluid3D([6292,6993,6643,6766],0); -ELEMENTS[35638] = Fluid3D([13565,13376,13349,12481],0); -ELEMENTS[35639] = Fluid3D([14362,15013,14839,14948],0); -ELEMENTS[35640] = Fluid3D([14362,15013,14948,14201],0); -ELEMENTS[35641] = Fluid3D([9552,8683,9175,9476],0); -ELEMENTS[35642] = Fluid3D([11519,11241,10524,11197],0); -ELEMENTS[35643] = Fluid3D([14584,14800,15029,14551],0); -ELEMENTS[35644] = Fluid3D([10205,9311,9378,8909],0); -ELEMENTS[35645] = Fluid3D([9311,9378,8909,8402],0); -ELEMENTS[35646] = Fluid3D([6268,5665,6084,5549],0); -ELEMENTS[35647] = Fluid3D([2718,3022,2997,2905],0); -ELEMENTS[35648] = Fluid3D([7639,8195,8351,8645],0); -ELEMENTS[35649] = Fluid3D([3785,4312,3995,4330],0); -ELEMENTS[35650] = Fluid3D([17082,17297,17004,17444],0); -ELEMENTS[35651] = Fluid3D([17082,17297,17444,17434],0); -ELEMENTS[35652] = Fluid3D([17614,17682,17730,18070],0); -ELEMENTS[35653] = Fluid3D([6139,5652,6305,6189],0); -ELEMENTS[35654] = Fluid3D([12551,13380,13015,12666],0); -ELEMENTS[35655] = Fluid3D([4183,4130,4558,4684],0); -ELEMENTS[35656] = Fluid3D([5211,5490,5046,4715],0); -ELEMENTS[35657] = Fluid3D([10156,9832,9944,10851],0); -ELEMENTS[35658] = Fluid3D([9944,10156,10851,10874],0); -ELEMENTS[35659] = Fluid3D([12045,12560,12589,13303],0); -ELEMENTS[35660] = Fluid3D([17922,18164,18082,17945],0); -ELEMENTS[35661] = Fluid3D([13071,12389,12957,13224],0); -ELEMENTS[35662] = Fluid3D([13069,12761,12484,13612],0); -ELEMENTS[35663] = Fluid3D([13069,12761,13612,13698],0); -ELEMENTS[35664] = Fluid3D([14543,14559,14891,15086],0); -ELEMENTS[35665] = Fluid3D([14559,14891,15086,15366],0); -ELEMENTS[35666] = Fluid3D([15086,14559,15366,15339],0); -ELEMENTS[35667] = Fluid3D([15366,15086,15339,15664],0); -ELEMENTS[35668] = Fluid3D([15366,15086,15664,14891],0); -ELEMENTS[35669] = Fluid3D([14543,14559,15086,15339],0); -ELEMENTS[35670] = Fluid3D([17810,17712,17674,17949],0); -ELEMENTS[35671] = Fluid3D([6806,6624,7310,6483],0); -ELEMENTS[35672] = Fluid3D([7310,6806,6483,7119],0); -ELEMENTS[35673] = Fluid3D([5408,5694,5397,5924],0); -ELEMENTS[35674] = Fluid3D([15693,15238,15219,15577],0); -ELEMENTS[35675] = Fluid3D([15693,15238,15577,15830],0); -ELEMENTS[35676] = Fluid3D([15693,15238,15830,15486],0); -ELEMENTS[35677] = Fluid3D([15693,15238,15486,14832],0); -ELEMENTS[35678] = Fluid3D([7682,8298,8085,7787],0); -ELEMENTS[35679] = Fluid3D([7682,8298,7787,7677],0); -ELEMENTS[35680] = Fluid3D([7682,8298,7677,7292],0); -ELEMENTS[35681] = Fluid3D([7787,7682,7677,6854],0); -ELEMENTS[35682] = Fluid3D([7677,7682,7292,6854],0); -ELEMENTS[35683] = Fluid3D([8298,7787,7677,7722],0); -ELEMENTS[35684] = Fluid3D([7292,7677,6854,7195],0); -ELEMENTS[35685] = Fluid3D([7677,6854,7195,6836],0); -ELEMENTS[35686] = Fluid3D([7292,7677,7195,7772],0); -ELEMENTS[35687] = Fluid3D([6854,7195,6836,6318],0); -ELEMENTS[35688] = Fluid3D([7787,7677,7722,6836],0); -ELEMENTS[35689] = Fluid3D([2949,2999,3172,2910],0); -ELEMENTS[35690] = Fluid3D([17712,17553,17909,17433],0); -ELEMENTS[35691] = Fluid3D([14998,14440,14971,14031],0); -ELEMENTS[35692] = Fluid3D([4448,3956,3992,4144],0); -ELEMENTS[35693] = Fluid3D([12767,13101,13433,14025],0); -ELEMENTS[35694] = Fluid3D([4650,4451,4314,4752],0); -ELEMENTS[35695] = Fluid3D([14451,14134,13998,13873],0); -ELEMENTS[35696] = Fluid3D([12473,11737,12233,12737],0); -ELEMENTS[35697] = Fluid3D([14953,15416,15402,15805],0); -ELEMENTS[35698] = Fluid3D([2735,2582,2906,3037],0); -ELEMENTS[35699] = Fluid3D([5053,4467,4737,4637],0); -ELEMENTS[35700] = Fluid3D([13059,13448,12655,12672],0); -ELEMENTS[35701] = Fluid3D([13448,12655,12672,13746],0); -ELEMENTS[35702] = Fluid3D([12655,13059,12672,12156],0); -ELEMENTS[35703] = Fluid3D([5346,5256,4776,4957],0); -ELEMENTS[35704] = Fluid3D([5256,4776,4957,4734],0); -ELEMENTS[35705] = Fluid3D([3807,3511,3421,3688],0); -ELEMENTS[35706] = Fluid3D([17848,17749,17967,17851],0); -ELEMENTS[35707] = Fluid3D([10866,10976,10634,11852],0); -ELEMENTS[35708] = Fluid3D([7872,8274,8465,8116],0); -ELEMENTS[35709] = Fluid3D([4348,3885,4326,4154],0); -ELEMENTS[35710] = Fluid3D([4348,3885,4154,3899],0); -ELEMENTS[35711] = Fluid3D([7238,7336,6740,6814],0); -ELEMENTS[35712] = Fluid3D([17234,17369,17644,17551],0); -ELEMENTS[35713] = Fluid3D([10674,11169,11378,11717],0); -ELEMENTS[35714] = Fluid3D([10674,11169,11717,10829],0); -ELEMENTS[35715] = Fluid3D([5296,4906,5070,5625],0); -ELEMENTS[35716] = Fluid3D([5070,5296,5625,5649],0); -ELEMENTS[35717] = Fluid3D([6430,6032,6585,7217],0); -ELEMENTS[35718] = Fluid3D([6060,6491,6002,5979],0); -ELEMENTS[35719] = Fluid3D([5541,5171,5744,5747],0); -ELEMENTS[35720] = Fluid3D([7719,6873,7299,7723],0); -ELEMENTS[35721] = Fluid3D([10486,11144,10721,10020],0); -ELEMENTS[35722] = Fluid3D([11236,11173,10968,12001],0); -ELEMENTS[35723] = Fluid3D([15938,16451,16064,15994],0); -ELEMENTS[35724] = Fluid3D([11318,11051,10814,12074],0); -ELEMENTS[35725] = Fluid3D([2566,2653,2800,3032],0); -ELEMENTS[35726] = Fluid3D([14861,15189,14738,15305],0); -ELEMENTS[35727] = Fluid3D([14738,14861,15305,14657],0); -ELEMENTS[35728] = Fluid3D([15189,14738,15305,15051],0); -ELEMENTS[35729] = Fluid3D([15047,15736,15537,15450],0); -ELEMENTS[35730] = Fluid3D([15537,15047,15450,14909],0); -ELEMENTS[35731] = Fluid3D([15047,15450,14909,15304],0); -ELEMENTS[35732] = Fluid3D([15450,14909,15304,15316],0); -ELEMENTS[35733] = Fluid3D([15304,15450,15316,16005],0); -ELEMENTS[35734] = Fluid3D([15450,15316,16005,15537],0); -ELEMENTS[35735] = Fluid3D([15304,15450,16005,15736],0); -ELEMENTS[35736] = Fluid3D([15450,15316,15537,14909],0); -ELEMENTS[35737] = Fluid3D([16005,15450,15537,15736],0); -ELEMENTS[35738] = Fluid3D([15047,15736,15450,15304],0); -ELEMENTS[35739] = Fluid3D([14733,15517,15131,15136],0); -ELEMENTS[35740] = Fluid3D([14733,15517,15136,15205],0); -ELEMENTS[35741] = Fluid3D([3299,2964,3357,3369],0); -ELEMENTS[35742] = Fluid3D([4234,4408,4676,4012],0); -ELEMENTS[35743] = Fluid3D([10287,10861,10544,11317],0); -ELEMENTS[35744] = Fluid3D([11796,11963,11769,10711],0); -ELEMENTS[35745] = Fluid3D([9316,9535,10372,10109],0); -ELEMENTS[35746] = Fluid3D([5917,5881,5841,5043],0); -ELEMENTS[35747] = Fluid3D([14486,14887,15318,14500],0); -ELEMENTS[35748] = Fluid3D([2740,2564,2995,2705],0); -ELEMENTS[35749] = Fluid3D([11345,11404,11740,12638],0); -ELEMENTS[35750] = Fluid3D([15981,16100,15672,15341],0); -ELEMENTS[35751] = Fluid3D([15672,15981,15341,15754],0); -ELEMENTS[35752] = Fluid3D([15672,15981,15754,15760],0); -ELEMENTS[35753] = Fluid3D([15754,15672,15760,15341],0); -ELEMENTS[35754] = Fluid3D([15672,15760,15341,15612],0); -ELEMENTS[35755] = Fluid3D([15341,15672,15612,15530],0); -ELEMENTS[35756] = Fluid3D([15672,15760,15612,16150],0); -ELEMENTS[35757] = Fluid3D([15612,15672,16150,15530],0); -ELEMENTS[35758] = Fluid3D([13657,13389,12843,12981],0); -ELEMENTS[35759] = Fluid3D([13148,13562,12676,14056],0); -ELEMENTS[35760] = Fluid3D([16211,16041,15823,16289],0); -ELEMENTS[35761] = Fluid3D([15669,15803,15346,15203],0); -ELEMENTS[35762] = Fluid3D([15669,15803,15203,15277],0); -ELEMENTS[35763] = Fluid3D([7832,8181,8567,9107],0); -ELEMENTS[35764] = Fluid3D([18072,18104,18304,18242],0); -ELEMENTS[35765] = Fluid3D([14485,14822,13914,14238],0); -ELEMENTS[35766] = Fluid3D([14485,14822,14238,14952],0); -ELEMENTS[35767] = Fluid3D([14485,14822,14952,15502],0); -ELEMENTS[35768] = Fluid3D([8073,8269,7810,8748],0); -ELEMENTS[35769] = Fluid3D([8073,8269,8748,8676],0); -ELEMENTS[35770] = Fluid3D([8269,8748,8676,9366],0); -ELEMENTS[35771] = Fluid3D([12439,12380,11957,11446],0); -ELEMENTS[35772] = Fluid3D([11348,11716,12419,10752],0); -ELEMENTS[35773] = Fluid3D([13660,12858,13539,12423],0); -ELEMENTS[35774] = Fluid3D([4543,4844,4206,4326],0); -ELEMENTS[35775] = Fluid3D([4819,4413,5131,4431],0); -ELEMENTS[35776] = Fluid3D([4819,4413,4431,4606],0); -ELEMENTS[35777] = Fluid3D([15809,15211,15465,14875],0); -ELEMENTS[35778] = Fluid3D([15563,15657,16066,16268],0); -ELEMENTS[35779] = Fluid3D([4111,4118,3909,3547],0); -ELEMENTS[35780] = Fluid3D([12919,13638,12903,12240],0); -ELEMENTS[35781] = Fluid3D([14372,14042,14929,13702],0); -ELEMENTS[35782] = Fluid3D([3062,3432,3234,3340],0); -ELEMENTS[35783] = Fluid3D([3432,3234,3340,3686],0); -ELEMENTS[35784] = Fluid3D([3432,3234,3686,3595],0); -ELEMENTS[35785] = Fluid3D([3340,3432,3686,3813],0); -ELEMENTS[35786] = Fluid3D([12699,13548,13210,13490],0); -ELEMENTS[35787] = Fluid3D([12699,13548,13490,13287],0); -ELEMENTS[35788] = Fluid3D([13548,13210,13490,14069],0); -ELEMENTS[35789] = Fluid3D([13490,13548,14069,14391],0); -ELEMENTS[35790] = Fluid3D([13548,13210,14069,14194],0); -ELEMENTS[35791] = Fluid3D([14069,13490,14391,14274],0); -ELEMENTS[35792] = Fluid3D([14391,14069,14274,14642],0); -ELEMENTS[35793] = Fluid3D([13548,13490,13287,13955],0); -ELEMENTS[35794] = Fluid3D([13548,13490,13955,14391],0); -ELEMENTS[35795] = Fluid3D([14391,14069,14642,14528],0); -ELEMENTS[35796] = Fluid3D([13548,14069,14391,14528],0); -ELEMENTS[35797] = Fluid3D([15083,14377,14706,15324],0); -ELEMENTS[35798] = Fluid3D([15083,14377,15324,14796],0); -ELEMENTS[35799] = Fluid3D([15324,15083,14796,15539],0); -ELEMENTS[35800] = Fluid3D([15324,15083,15539,15930],0); -ELEMENTS[35801] = Fluid3D([5614,5370,5082,5640],0); -ELEMENTS[35802] = Fluid3D([5370,5082,5640,5771],0); -ELEMENTS[35803] = Fluid3D([5640,5370,5771,6259],0); -ELEMENTS[35804] = Fluid3D([12500,11709,11870,11908],0); -ELEMENTS[35805] = Fluid3D([15528,16020,15432,15572],0); -ELEMENTS[35806] = Fluid3D([15432,15528,15572,15018],0); -ELEMENTS[35807] = Fluid3D([15432,15528,15018,15002],0); -ELEMENTS[35808] = Fluid3D([15528,15018,15002,15527],0); -ELEMENTS[35809] = Fluid3D([16488,16767,17022,16855],0); -ELEMENTS[35810] = Fluid3D([16767,17022,16855,17074],0); -ELEMENTS[35811] = Fluid3D([16488,16767,16855,16514],0); -ELEMENTS[35812] = Fluid3D([16115,16312,16177,16603],0); -ELEMENTS[35813] = Fluid3D([16312,16177,16603,16556],0); -ELEMENTS[35814] = Fluid3D([16603,16312,16556,16874],0); -ELEMENTS[35815] = Fluid3D([16312,16177,16556,16230],0); -ELEMENTS[35816] = Fluid3D([16115,16312,16603,16444],0); -ELEMENTS[35817] = Fluid3D([16556,16603,16874,16850],0); -ELEMENTS[35818] = Fluid3D([16603,16874,16850,17142],0); -ELEMENTS[35819] = Fluid3D([16556,16603,16850,16177],0); -ELEMENTS[35820] = Fluid3D([16603,16850,16177,16484],0); -ELEMENTS[35821] = Fluid3D([16603,16850,16484,17142],0); -ELEMENTS[35822] = Fluid3D([4679,5236,5189,5035],0); -ELEMENTS[35823] = Fluid3D([8064,7628,7726,7501],0); -ELEMENTS[35824] = Fluid3D([8216,8281,8176,7608],0); -ELEMENTS[35825] = Fluid3D([15587,15182,15555,15094],0); -ELEMENTS[35826] = Fluid3D([15555,15587,15094,15609],0); -ELEMENTS[35827] = Fluid3D([7845,7375,8339,7771],0); -ELEMENTS[35828] = Fluid3D([10525,9760,10681,9906],0); -ELEMENTS[35829] = Fluid3D([5507,6147,5695,5794],0); -ELEMENTS[35830] = Fluid3D([14978,15078,15280,15518],0); -ELEMENTS[35831] = Fluid3D([14978,15078,15518,15349],0); -ELEMENTS[35832] = Fluid3D([14978,15078,15349,14895],0); -ELEMENTS[35833] = Fluid3D([15518,14978,15349,15104],0); -ELEMENTS[35834] = Fluid3D([8491,9022,9039,8502],0); -ELEMENTS[35835] = Fluid3D([11613,12167,11547,11772],0); -ELEMENTS[35836] = Fluid3D([11613,12167,11772,13049],0); -ELEMENTS[35837] = Fluid3D([11547,11613,11772,10951],0); -ELEMENTS[35838] = Fluid3D([12544,12587,11775,12855],0); -ELEMENTS[35839] = Fluid3D([17160,17507,17564,17477],0); -ELEMENTS[35840] = Fluid3D([17160,17507,17477,16958],0); -ELEMENTS[35841] = Fluid3D([3421,3156,3203,3688],0); -ELEMENTS[35842] = Fluid3D([4843,5013,5494,5517],0); -ELEMENTS[35843] = Fluid3D([17982,17796,17652,17530],0); -ELEMENTS[35844] = Fluid3D([9577,9352,9659,10541],0); -ELEMENTS[35845] = Fluid3D([8728,8128,8266,8982],0); -ELEMENTS[35846] = Fluid3D([8728,8128,8982,8835],0); -ELEMENTS[35847] = Fluid3D([3515,3424,3573,3816],0); -ELEMENTS[35848] = Fluid3D([3515,3424,3816,3688],0); -ELEMENTS[35849] = Fluid3D([14163,14398,14759,15054],0); -ELEMENTS[35850] = Fluid3D([17320,17593,17441,17283],0); -ELEMENTS[35851] = Fluid3D([17320,17593,17283,17123],0); -ELEMENTS[35852] = Fluid3D([13673,13432,14086,13942],0); -ELEMENTS[35853] = Fluid3D([13673,13432,13942,13472],0); -ELEMENTS[35854] = Fluid3D([18035,18284,18162,18105],0); -ELEMENTS[35855] = Fluid3D([4711,4623,4387,4164],0); -ELEMENTS[35856] = Fluid3D([6163,5553,6039,5842],0); -ELEMENTS[35857] = Fluid3D([10915,11415,10401,11614],0); -ELEMENTS[35858] = Fluid3D([11104,11840,11009,11603],0); -ELEMENTS[35859] = Fluid3D([5073,5367,4806,4894],0); -ELEMENTS[35860] = Fluid3D([17241,17159,17012,17502],0); -ELEMENTS[35861] = Fluid3D([16833,16424,16687,16289],0); -ELEMENTS[35862] = Fluid3D([17344,17448,17157,17001],0); -ELEMENTS[35863] = Fluid3D([17344,17448,17001,17253],0); -ELEMENTS[35864] = Fluid3D([4224,4570,4112,4204],0); -ELEMENTS[35865] = Fluid3D([4112,4224,4204,3783],0); -ELEMENTS[35866] = Fluid3D([9261,9911,9323,10479],0); -ELEMENTS[35867] = Fluid3D([9484,10834,10206,10402],0); -ELEMENTS[35868] = Fluid3D([11057,12015,11095,11570],0); -ELEMENTS[35869] = Fluid3D([7364,6566,6523,6835],0); -ELEMENTS[35870] = Fluid3D([15211,15158,14557,14699],0); -ELEMENTS[35871] = Fluid3D([9311,8909,8322,8402],0); -ELEMENTS[35872] = Fluid3D([18016,17754,17790,17968],0); -ELEMENTS[35873] = Fluid3D([2763,2979,2590,2710],0); -ELEMENTS[35874] = Fluid3D([8784,8072,8846,7791],0); -ELEMENTS[35875] = Fluid3D([4142,3861,4416,3962],0); -ELEMENTS[35876] = Fluid3D([15713,15881,15053,15275],0); -ELEMENTS[35877] = Fluid3D([3952,3810,3618,4044],0); -ELEMENTS[35878] = Fluid3D([3952,3810,4044,4327],0); -ELEMENTS[35879] = Fluid3D([8883,8364,8340,9341],0); -ELEMENTS[35880] = Fluid3D([12356,11788,12186,12279],0); -ELEMENTS[35881] = Fluid3D([12356,11788,12279,12707],0); -ELEMENTS[35882] = Fluid3D([8138,7961,7193,7675],0); -ELEMENTS[35883] = Fluid3D([5373,5173,5359,4780],0); -ELEMENTS[35884] = Fluid3D([5359,5373,4780,5228],0); -ELEMENTS[35885] = Fluid3D([5359,5373,5228,5907],0); -ELEMENTS[35886] = Fluid3D([14869,15272,15484,15232],0); -ELEMENTS[35887] = Fluid3D([16510,16620,16219,15735],0); -ELEMENTS[35888] = Fluid3D([16904,17159,17422,17133],0); -ELEMENTS[35889] = Fluid3D([10960,10149,10482,10712],0); -ELEMENTS[35890] = Fluid3D([10149,10482,10712,9637],0); -ELEMENTS[35891] = Fluid3D([10149,10482,9637,9427],0); -ELEMENTS[35892] = Fluid3D([10149,10482,9427,10284],0); -ELEMENTS[35893] = Fluid3D([16792,17201,17079,17331],0); -ELEMENTS[35894] = Fluid3D([17201,17079,17331,17460],0); -ELEMENTS[35895] = Fluid3D([17079,17331,17460,17263],0); -ELEMENTS[35896] = Fluid3D([17079,17331,17263,16761],0); -ELEMENTS[35897] = Fluid3D([17079,17331,16761,16921],0); -ELEMENTS[35898] = Fluid3D([17079,17331,16921,16792],0); -ELEMENTS[35899] = Fluid3D([17201,17079,17460,17122],0); -ELEMENTS[35900] = Fluid3D([17201,17079,17122,16808],0); -ELEMENTS[35901] = Fluid3D([17079,17460,17122,17218],0); -ELEMENTS[35902] = Fluid3D([17079,17460,17218,17263],0); -ELEMENTS[35903] = Fluid3D([17218,17079,17263,17065],0); -ELEMENTS[35904] = Fluid3D([17263,17218,17065,17542],0); -ELEMENTS[35905] = Fluid3D([17218,17065,17542,17487],0); -ELEMENTS[35906] = Fluid3D([17263,17218,17542,17460],0); -ELEMENTS[35907] = Fluid3D([17122,17079,17218,16849],0); -ELEMENTS[35908] = Fluid3D([17122,17079,16849,16808],0); -ELEMENTS[35909] = Fluid3D([16849,17122,16808,17110],0); -ELEMENTS[35910] = Fluid3D([16849,17122,17110,17039],0); -ELEMENTS[35911] = Fluid3D([17218,17122,16849,17039],0); -ELEMENTS[35912] = Fluid3D([17122,16808,17110,17201],0); -ELEMENTS[35913] = Fluid3D([17122,17110,17039,17453],0); -ELEMENTS[35914] = Fluid3D([17122,17110,17453,17522],0); -ELEMENTS[35915] = Fluid3D([17331,17201,17460,17705],0); -ELEMENTS[35916] = Fluid3D([17263,17079,16761,17065],0); -ELEMENTS[35917] = Fluid3D([17079,17218,16849,17065],0); -ELEMENTS[35918] = Fluid3D([17460,17201,17122,17522],0); -ELEMENTS[35919] = Fluid3D([17460,17122,17218,17453],0); -ELEMENTS[35920] = Fluid3D([17460,17122,17453,17522],0); -ELEMENTS[35921] = Fluid3D([17122,17110,17522,17201],0); -ELEMENTS[35922] = Fluid3D([17122,17218,17453,17039],0); -ELEMENTS[35923] = Fluid3D([17218,16849,17065,17039],0); -ELEMENTS[35924] = Fluid3D([14540,14361,13955,14397],0); -ELEMENTS[35925] = Fluid3D([5434,5242,5113,5751],0); -ELEMENTS[35926] = Fluid3D([9550,10069,10563,10545],0); -ELEMENTS[35927] = Fluid3D([13920,13365,13836,14643],0); -ELEMENTS[35928] = Fluid3D([11386,10434,11326,11783],0); -ELEMENTS[35929] = Fluid3D([8889,9012,8382,8330],0); -ELEMENTS[35930] = Fluid3D([13403,13412,13475,12448],0); -ELEMENTS[35931] = Fluid3D([14359,13558,13777,14373],0); -ELEMENTS[35932] = Fluid3D([17524,17562,17171,17231],0); -ELEMENTS[35933] = Fluid3D([17524,17562,17231,17516],0); -ELEMENTS[35934] = Fluid3D([15980,15905,15926,16292],0); -ELEMENTS[35935] = Fluid3D([15980,15905,16292,16344],0); -ELEMENTS[35936] = Fluid3D([15905,16292,16344,16628],0); -ELEMENTS[35937] = Fluid3D([15905,15926,16292,15556],0); -ELEMENTS[35938] = Fluid3D([15980,15905,16344,15898],0); -ELEMENTS[35939] = Fluid3D([15905,16344,15898,16628],0); -ELEMENTS[35940] = Fluid3D([3570,3344,3104,3476],0); -ELEMENTS[35941] = Fluid3D([14096,13756,14479,13858],0); -ELEMENTS[35942] = Fluid3D([18420,18489,18452,18555],0); -ELEMENTS[35943] = Fluid3D([6949,6540,7348,7213],0); -ELEMENTS[35944] = Fluid3D([7849,7185,7410,6908],0); -ELEMENTS[35945] = Fluid3D([5132,5732,5184,5682],0); -ELEMENTS[35946] = Fluid3D([2639,2926,3112,3053],0); -ELEMENTS[35947] = Fluid3D([5648,5075,5511,5679],0); -ELEMENTS[35948] = Fluid3D([15835,16318,16150,16273],0); -ELEMENTS[35949] = Fluid3D([6415,7171,6860,7461],0); -ELEMENTS[35950] = Fluid3D([4075,4461,4518,4924],0); -ELEMENTS[35951] = Fluid3D([10990,11299,10640,10495],0); -ELEMENTS[35952] = Fluid3D([11299,10640,10495,10956],0); -ELEMENTS[35953] = Fluid3D([5581,5979,6203,5632],0); -ELEMENTS[35954] = Fluid3D([10937,11056,12000,11349],0); -ELEMENTS[35955] = Fluid3D([17885,17808,17634,17662],0); -ELEMENTS[35956] = Fluid3D([17634,17885,17662,17989],0); -ELEMENTS[35957] = Fluid3D([17885,17662,17989,17910],0); -ELEMENTS[35958] = Fluid3D([17885,17662,17910,17767],0); -ELEMENTS[35959] = Fluid3D([17662,17910,17767,17669],0); -ELEMENTS[35960] = Fluid3D([17989,17885,17910,18120],0); -ELEMENTS[35961] = Fluid3D([17989,17885,18120,18181],0); -ELEMENTS[35962] = Fluid3D([17989,17885,18181,17902],0); -ELEMENTS[35963] = Fluid3D([17910,17767,17669,17837],0); -ELEMENTS[35964] = Fluid3D([17910,17767,17837,18053],0); -ELEMENTS[35965] = Fluid3D([17767,17669,17837,17426],0); -ELEMENTS[35966] = Fluid3D([17837,17767,17426,17450],0); -ELEMENTS[35967] = Fluid3D([17767,17837,18053,17917],0); -ELEMENTS[35968] = Fluid3D([18053,17767,17917,17983],0); -ELEMENTS[35969] = Fluid3D([17917,18053,17983,18242],0); -ELEMENTS[35970] = Fluid3D([17837,18053,17917,17991],0); -ELEMENTS[35971] = Fluid3D([18053,17917,17991,18180],0); -ELEMENTS[35972] = Fluid3D([18053,17917,18180,18242],0); -ELEMENTS[35973] = Fluid3D([17917,17991,18180,17818],0); -ELEMENTS[35974] = Fluid3D([3328,3364,2985,3070],0); -ELEMENTS[35975] = Fluid3D([3328,3364,3070,3594],0); -ELEMENTS[35976] = Fluid3D([14139,14005,14357,14727],0); -ELEMENTS[35977] = Fluid3D([8155,7651,7421,8211],0); -ELEMENTS[35978] = Fluid3D([8155,7651,8211,8269],0); -ELEMENTS[35979] = Fluid3D([7421,8155,8211,8067],0); -ELEMENTS[35980] = Fluid3D([8645,8218,8441,7886],0); -ELEMENTS[35981] = Fluid3D([8645,8218,7886,7639],0); -ELEMENTS[35982] = Fluid3D([8325,8018,7711,8533],0); -ELEMENTS[35983] = Fluid3D([12401,12223,11766,12729],0); -ELEMENTS[35984] = Fluid3D([12401,12223,12729,13032],0); -ELEMENTS[35985] = Fluid3D([12401,12223,13032,12971],0); -ELEMENTS[35986] = Fluid3D([13032,12401,12971,13070],0); -ELEMENTS[35987] = Fluid3D([13032,12401,13070,12830],0); -ELEMENTS[35988] = Fluid3D([13032,12401,12830,12893],0); -ELEMENTS[35989] = Fluid3D([13032,12401,12893,12729],0); -ELEMENTS[35990] = Fluid3D([12401,12893,12729,12194],0); -ELEMENTS[35991] = Fluid3D([12893,12729,12194,13204],0); -ELEMENTS[35992] = Fluid3D([12971,13032,13070,13328],0); -ELEMENTS[35993] = Fluid3D([12971,13032,13328,12223],0); -ELEMENTS[35994] = Fluid3D([13032,13070,13328,13590],0); -ELEMENTS[35995] = Fluid3D([13328,13032,13590,13621],0); -ELEMENTS[35996] = Fluid3D([13032,13070,13590,13391],0); -ELEMENTS[35997] = Fluid3D([13070,13590,13391,13701],0); -ELEMENTS[35998] = Fluid3D([13590,13391,13701,13621],0); -ELEMENTS[35999] = Fluid3D([13590,13391,13621,13032],0); -ELEMENTS[36000] = Fluid3D([13070,13590,13701,13639],0); -ELEMENTS[36001] = Fluid3D([13032,13328,12223,12729],0); -ELEMENTS[36002] = Fluid3D([13070,13590,13639,13328],0); -ELEMENTS[36003] = Fluid3D([13701,13590,13621,14511],0); -ELEMENTS[36004] = Fluid3D([13328,13032,13621,13514],0); -ELEMENTS[36005] = Fluid3D([13328,13032,13514,12893],0); -ELEMENTS[36006] = Fluid3D([13328,13032,12893,12729],0); -ELEMENTS[36007] = Fluid3D([13032,13514,12893,13621],0); -ELEMENTS[36008] = Fluid3D([13514,13328,12893,13500],0); -ELEMENTS[36009] = Fluid3D([12893,13514,13500,13795],0); -ELEMENTS[36010] = Fluid3D([13514,13500,13795,13981],0); -ELEMENTS[36011] = Fluid3D([12893,13514,13795,13361],0); -ELEMENTS[36012] = Fluid3D([12893,13514,13361,12830],0); -ELEMENTS[36013] = Fluid3D([13514,13328,13500,13981],0); -ELEMENTS[36014] = Fluid3D([13514,13795,13361,13621],0); -ELEMENTS[36015] = Fluid3D([13500,12893,13795,13094],0); -ELEMENTS[36016] = Fluid3D([13391,13070,13701,12830],0); -ELEMENTS[36017] = Fluid3D([13391,13701,13621,13603],0); -ELEMENTS[36018] = Fluid3D([13621,13391,13603,13361],0); -ELEMENTS[36019] = Fluid3D([12893,13328,12729,13500],0); -ELEMENTS[36020] = Fluid3D([12729,12893,13500,13204],0); -ELEMENTS[36021] = Fluid3D([13032,13070,13391,12830],0); -ELEMENTS[36022] = Fluid3D([13500,13795,13981,14363],0); -ELEMENTS[36023] = Fluid3D([13328,12223,12729,12971],0); -ELEMENTS[36024] = Fluid3D([13590,13621,14511,14394],0); -ELEMENTS[36025] = Fluid3D([13070,12971,13328,13121],0); -ELEMENTS[36026] = Fluid3D([13795,13500,13094,13204],0); -ELEMENTS[36027] = Fluid3D([13070,12971,13121,12142],0); -ELEMENTS[36028] = Fluid3D([13701,13391,12830,13603],0); -ELEMENTS[36029] = Fluid3D([13391,12830,13603,13361],0); -ELEMENTS[36030] = Fluid3D([13795,13514,13981,13621],0); -ELEMENTS[36031] = Fluid3D([13590,13621,14394,13981],0); -ELEMENTS[36032] = Fluid3D([13391,13621,13032,12830],0); -ELEMENTS[36033] = Fluid3D([13391,13621,12830,13361],0); -ELEMENTS[36034] = Fluid3D([13590,13701,13639,14394],0); -ELEMENTS[36035] = Fluid3D([13639,13590,14394,13328],0); -ELEMENTS[36036] = Fluid3D([13590,13328,13621,13981],0); -ELEMENTS[36037] = Fluid3D([13361,13514,13621,12830],0); -ELEMENTS[36038] = Fluid3D([13621,13328,13514,13981],0); -ELEMENTS[36039] = Fluid3D([12223,11766,12729,11686],0); -ELEMENTS[36040] = Fluid3D([12729,12223,11686,12241],0); -ELEMENTS[36041] = Fluid3D([12401,12830,12893,12463],0); -ELEMENTS[36042] = Fluid3D([12893,12401,12463,12194],0); -ELEMENTS[36043] = Fluid3D([12879,13467,13055,12582],0); -ELEMENTS[36044] = Fluid3D([3992,3868,3956,4425],0); -ELEMENTS[36045] = Fluid3D([9400,9409,9378,8498],0); -ELEMENTS[36046] = Fluid3D([15928,15850,16189,15693],0); -ELEMENTS[36047] = Fluid3D([15850,16189,15693,15577],0); -ELEMENTS[36048] = Fluid3D([15928,15850,15693,15219],0); -ELEMENTS[36049] = Fluid3D([15693,15850,15577,15219],0); -ELEMENTS[36050] = Fluid3D([8369,8331,8606,9338],0); -ELEMENTS[36051] = Fluid3D([16964,16544,17008,16968],0); -ELEMENTS[36052] = Fluid3D([12410,12133,12793,13279],0); -ELEMENTS[36053] = Fluid3D([17387,17624,17618,17224],0); -ELEMENTS[36054] = Fluid3D([5844,5997,5660,6566],0); -ELEMENTS[36055] = Fluid3D([14887,15002,15318,15432],0); -ELEMENTS[36056] = Fluid3D([15318,14887,15432,15036],0); -ELEMENTS[36057] = Fluid3D([15318,14887,15036,14500],0); -ELEMENTS[36058] = Fluid3D([13851,13755,13049,12949],0); -ELEMENTS[36059] = Fluid3D([6401,6158,5979,5738],0); -ELEMENTS[36060] = Fluid3D([17121,17117,17300,16601],0); -ELEMENTS[36061] = Fluid3D([11076,10360,11040,10394],0); -ELEMENTS[36062] = Fluid3D([11076,10360,10394,10291],0); -ELEMENTS[36063] = Fluid3D([11076,10360,10291,9927],0); -ELEMENTS[36064] = Fluid3D([10360,10394,10291,9666],0); -ELEMENTS[36065] = Fluid3D([10360,10394,9666,9642],0); -ELEMENTS[36066] = Fluid3D([10394,9666,9642,9575],0); -ELEMENTS[36067] = Fluid3D([9666,9642,9575,8757],0); -ELEMENTS[36068] = Fluid3D([9642,10394,9575,10335],0); -ELEMENTS[36069] = Fluid3D([9666,9642,8757,9446],0); -ELEMENTS[36070] = Fluid3D([9666,9642,9446,10360],0); -ELEMENTS[36071] = Fluid3D([8757,9666,9446,9030],0); -ELEMENTS[36072] = Fluid3D([9666,9446,9030,9734],0); -ELEMENTS[36073] = Fluid3D([9446,9666,10360,9734],0); -ELEMENTS[36074] = Fluid3D([9642,10394,10335,11040],0); -ELEMENTS[36075] = Fluid3D([8757,9666,9030,9037],0); -ELEMENTS[36076] = Fluid3D([9666,9030,9037,9927],0); -ELEMENTS[36077] = Fluid3D([9446,8757,9030,8180],0); -ELEMENTS[36078] = Fluid3D([8757,9666,9037,9575],0); -ELEMENTS[36079] = Fluid3D([9666,9037,9575,9922],0); -ELEMENTS[36080] = Fluid3D([9037,9575,9922,9399],0); -ELEMENTS[36081] = Fluid3D([9037,9575,9399,8933],0); -ELEMENTS[36082] = Fluid3D([9922,9037,9399,9927],0); -ELEMENTS[36083] = Fluid3D([9575,9922,9399,10526],0); -ELEMENTS[36084] = Fluid3D([9922,9399,10526,9927],0); -ELEMENTS[36085] = Fluid3D([10526,9922,9927,10291],0); -ELEMENTS[36086] = Fluid3D([9922,9927,10291,9666],0); -ELEMENTS[36087] = Fluid3D([10526,9922,10291,10394],0); -ELEMENTS[36088] = Fluid3D([10291,9922,9666,10394],0); -ELEMENTS[36089] = Fluid3D([9927,10526,10291,11076],0); -ELEMENTS[36090] = Fluid3D([9399,9037,8933,8368],0); -ELEMENTS[36091] = Fluid3D([9399,9037,8368,8855],0); -ELEMENTS[36092] = Fluid3D([9399,9037,8855,9927],0); -ELEMENTS[36093] = Fluid3D([9575,9922,10526,10394],0); -ELEMENTS[36094] = Fluid3D([9575,9666,9922,10394],0); -ELEMENTS[36095] = Fluid3D([9666,9037,9922,9927],0); -ELEMENTS[36096] = Fluid3D([9037,8368,8855,9030],0); -ELEMENTS[36097] = Fluid3D([8855,9037,9030,9927],0); -ELEMENTS[36098] = Fluid3D([9642,8757,9446,8865],0); -ELEMENTS[36099] = Fluid3D([10291,10360,9666,9927],0); -ELEMENTS[36100] = Fluid3D([9037,9575,8933,8661],0); -ELEMENTS[36101] = Fluid3D([9037,9575,8661,8757],0); -ELEMENTS[36102] = Fluid3D([9575,8933,8661,9353],0); -ELEMENTS[36103] = Fluid3D([8661,9575,9353,8757],0); -ELEMENTS[36104] = Fluid3D([8933,9037,8661,8368],0); -ELEMENTS[36105] = Fluid3D([8933,8661,9353,8460],0); -ELEMENTS[36106] = Fluid3D([9037,8661,8368,8757],0); -ELEMENTS[36107] = Fluid3D([10360,11040,10394,9642],0); -ELEMENTS[36108] = Fluid3D([10526,10291,11076,10394],0); -ELEMENTS[36109] = Fluid3D([8661,8933,8368,7904],0); -ELEMENTS[36110] = Fluid3D([8661,8933,7904,8460],0); -ELEMENTS[36111] = Fluid3D([8757,9446,8865,8180],0); -ELEMENTS[36112] = Fluid3D([9030,8757,9037,8368],0); -ELEMENTS[36113] = Fluid3D([8694,8668,9321,8915],0); -ELEMENTS[36114] = Fluid3D([14341,14805,14820,15385],0); -ELEMENTS[36115] = Fluid3D([15577,15590,14948,14839],0); -ELEMENTS[36116] = Fluid3D([7106,6630,7113,6014],0); -ELEMENTS[36117] = Fluid3D([11519,11241,11197,12283],0); -ELEMENTS[36118] = Fluid3D([12726,12046,12922,12358],0); -ELEMENTS[36119] = Fluid3D([3281,3133,3462,3318],0); -ELEMENTS[36120] = Fluid3D([3281,3133,3318,2910],0); -ELEMENTS[36121] = Fluid3D([16941,17268,17351,16951],0); -ELEMENTS[36122] = Fluid3D([16969,16740,17109,16597],0); -ELEMENTS[36123] = Fluid3D([17109,16969,16597,16636],0); -ELEMENTS[36124] = Fluid3D([13794,13965,13880,13016],0); -ELEMENTS[36125] = Fluid3D([10349,10500,11223,10984],0); -ELEMENTS[36126] = Fluid3D([13485,13928,14286,14315],0); -ELEMENTS[36127] = Fluid3D([2971,2846,2627,2866],0); -ELEMENTS[36128] = Fluid3D([17060,17237,17565,17258],0); -ELEMENTS[36129] = Fluid3D([4371,4295,4797,4422],0); -ELEMENTS[36130] = Fluid3D([3823,3392,3273,3949],0); -ELEMENTS[36131] = Fluid3D([2817,2536,2794,2527],0); -ELEMENTS[36132] = Fluid3D([14825,14071,14517,14250],0); -ELEMENTS[36133] = Fluid3D([17433,17904,17670,17731],0); -ELEMENTS[36134] = Fluid3D([17670,17433,17731,17236],0); -ELEMENTS[36135] = Fluid3D([17904,17670,17731,17875],0); -ELEMENTS[36136] = Fluid3D([14076,13192,13751,13581],0); -ELEMENTS[36137] = Fluid3D([13192,13751,13581,12967],0); -ELEMENTS[36138] = Fluid3D([13192,13751,12967,13242],0); -ELEMENTS[36139] = Fluid3D([13581,13192,12967,12732],0); -ELEMENTS[36140] = Fluid3D([13751,13581,12967,13918],0); -ELEMENTS[36141] = Fluid3D([10199,9648,9472,10345],0); -ELEMENTS[36142] = Fluid3D([9472,10199,10345,10893],0); -ELEMENTS[36143] = Fluid3D([5661,5574,5878,6239],0); -ELEMENTS[36144] = Fluid3D([3446,3527,3353,3154],0); -ELEMENTS[36145] = Fluid3D([6002,5374,5494,5517],0); -ELEMENTS[36146] = Fluid3D([10530,10676,9745,10428],0); -ELEMENTS[36147] = Fluid3D([12715,12236,12074,12936],0); -ELEMENTS[36148] = Fluid3D([12236,12074,12936,11890],0); -ELEMENTS[36149] = Fluid3D([12074,12715,12936,12898],0); -ELEMENTS[36150] = Fluid3D([12936,12074,12898,12165],0); -ELEMENTS[36151] = Fluid3D([12715,12936,12898,13395],0); -ELEMENTS[36152] = Fluid3D([12898,12715,13395,12107],0); -ELEMENTS[36153] = Fluid3D([12074,12715,12898,12107],0); -ELEMENTS[36154] = Fluid3D([16363,16909,16818,16624],0); -ELEMENTS[36155] = Fluid3D([16187,15976,15802,16044],0); -ELEMENTS[36156] = Fluid3D([2416,2542,2354,2648],0); -ELEMENTS[36157] = Fluid3D([12591,12526,12781,11863],0); -ELEMENTS[36158] = Fluid3D([3108,3064,2899,2626],0); -ELEMENTS[36159] = Fluid3D([17767,17425,17660,17662],0); -ELEMENTS[36160] = Fluid3D([17660,17767,17662,17885],0); -ELEMENTS[36161] = Fluid3D([17767,17425,17662,17669],0); -ELEMENTS[36162] = Fluid3D([10615,10436,11189,11171],0); -ELEMENTS[36163] = Fluid3D([17174,16731,16998,16512],0); -ELEMENTS[36164] = Fluid3D([18486,18355,18497,18467],0); -ELEMENTS[36165] = Fluid3D([12353,12022,12951,12487],0); -ELEMENTS[36166] = Fluid3D([12022,12951,12487,12983],0); -ELEMENTS[36167] = Fluid3D([12353,12022,12487,11589],0); -ELEMENTS[36168] = Fluid3D([4055,3942,3748,4166],0); -ELEMENTS[36169] = Fluid3D([11160,11808,11889,12544],0); -ELEMENTS[36170] = Fluid3D([11443,12131,12231,12203],0); -ELEMENTS[36171] = Fluid3D([17074,16579,16514,17051],0); -ELEMENTS[36172] = Fluid3D([10256,9511,9484,9456],0); -ELEMENTS[36173] = Fluid3D([5542,5349,5885,4957],0); -ELEMENTS[36174] = Fluid3D([13458,14002,13819,14235],0); -ELEMENTS[36175] = Fluid3D([10567,11546,11313,10384],0); -ELEMENTS[36176] = Fluid3D([7808,7067,7848,6919],0); -ELEMENTS[36177] = Fluid3D([11219,10655,11350,10962],0); -ELEMENTS[36178] = Fluid3D([3643,3211,3437,3388],0); -ELEMENTS[36179] = Fluid3D([3643,3211,3388,3336],0); -ELEMENTS[36180] = Fluid3D([11276,10970,11321,10629],0); -ELEMENTS[36181] = Fluid3D([10970,11321,10629,10218],0); -ELEMENTS[36182] = Fluid3D([11321,10629,10218,11187],0); -ELEMENTS[36183] = Fluid3D([11321,11276,10629,11950],0); -ELEMENTS[36184] = Fluid3D([14334,14770,14216,14389],0); -ELEMENTS[36185] = Fluid3D([10880,10837,11516,11683],0); -ELEMENTS[36186] = Fluid3D([17335,17362,17349,16880],0); -ELEMENTS[36187] = Fluid3D([14139,14509,14569,15181],0); -ELEMENTS[36188] = Fluid3D([14509,14569,15181,15251],0); -ELEMENTS[36189] = Fluid3D([14509,14569,15251,15045],0); -ELEMENTS[36190] = Fluid3D([10721,11144,11472,10091],0); -ELEMENTS[36191] = Fluid3D([10090,9518,10545,10737],0); -ELEMENTS[36192] = Fluid3D([10396,10058,11249,10314],0); -ELEMENTS[36193] = Fluid3D([5822,5711,5369,6349],0); -ELEMENTS[36194] = Fluid3D([5975,5776,6099,5162],0); -ELEMENTS[36195] = Fluid3D([13633,13657,12843,12876],0); -ELEMENTS[36196] = Fluid3D([12990,12569,12562,13632],0); -ELEMENTS[36197] = Fluid3D([5005,5470,5489,5617],0); -ELEMENTS[36198] = Fluid3D([5470,5489,5617,6090],0); -ELEMENTS[36199] = Fluid3D([5470,5489,6090,5848],0); -ELEMENTS[36200] = Fluid3D([5489,5617,6090,6234],0); -ELEMENTS[36201] = Fluid3D([17576,17783,17976,17742],0); -ELEMENTS[36202] = Fluid3D([8801,8832,9403,8406],0); -ELEMENTS[36203] = Fluid3D([11536,12367,11300,12212],0); -ELEMENTS[36204] = Fluid3D([16395,16705,15986,16221],0); -ELEMENTS[36205] = Fluid3D([17679,17662,17757,17989],0); -ELEMENTS[36206] = Fluid3D([17757,17679,17989,17847],0); -ELEMENTS[36207] = Fluid3D([17757,17679,17847,17585],0); -ELEMENTS[36208] = Fluid3D([17679,17989,17847,18066],0); -ELEMENTS[36209] = Fluid3D([5613,5244,5449,4863],0); -ELEMENTS[36210] = Fluid3D([5244,5449,4863,5088],0); -ELEMENTS[36211] = Fluid3D([5244,5449,5088,5612],0); -ELEMENTS[36212] = Fluid3D([5449,4863,5088,4673],0); -ELEMENTS[36213] = Fluid3D([4863,5244,5088,4742],0); -ELEMENTS[36214] = Fluid3D([1802,1868,1814,1706],0); -ELEMENTS[36215] = Fluid3D([1802,1868,1706,1705],0); -ELEMENTS[36216] = Fluid3D([1814,1802,1706,1856],0); -ELEMENTS[36217] = Fluid3D([6770,7265,6366,6641],0); -ELEMENTS[36218] = Fluid3D([6466,5827,5944,6042],0); -ELEMENTS[36219] = Fluid3D([17053,17174,16998,17485],0); -ELEMENTS[36220] = Fluid3D([17053,17174,17485,17073],0); -ELEMENTS[36221] = Fluid3D([17174,17485,17073,17520],0); -ELEMENTS[36222] = Fluid3D([17372,17052,17384,17374],0); -ELEMENTS[36223] = Fluid3D([10171,9992,10597,10426],0); -ELEMENTS[36224] = Fluid3D([8461,9236,9686,8475],0); -ELEMENTS[36225] = Fluid3D([17583,17121,17300,17440],0); -ELEMENTS[36226] = Fluid3D([4763,5016,5176,5324],0); -ELEMENTS[36227] = Fluid3D([4110,3935,4057,3756],0); -ELEMENTS[36228] = Fluid3D([4057,4110,3756,4105],0); -ELEMENTS[36229] = Fluid3D([4110,3756,4105,3863],0); -ELEMENTS[36230] = Fluid3D([4110,3756,3863,3788],0); -ELEMENTS[36231] = Fluid3D([3756,4105,3863,3662],0); -ELEMENTS[36232] = Fluid3D([3863,3756,3662,3330],0); -ELEMENTS[36233] = Fluid3D([3756,4105,3662,3553],0); -ELEMENTS[36234] = Fluid3D([4110,3935,3756,3788],0); -ELEMENTS[36235] = Fluid3D([4105,4110,3863,4424],0); -ELEMENTS[36236] = Fluid3D([4105,4110,4424,4641],0); -ELEMENTS[36237] = Fluid3D([4110,3863,4424,4232],0); -ELEMENTS[36238] = Fluid3D([3662,3756,3553,3330],0); -ELEMENTS[36239] = Fluid3D([13541,13364,14139,13238],0); -ELEMENTS[36240] = Fluid3D([14139,13541,13238,14273],0); -ELEMENTS[36241] = Fluid3D([13541,13364,13238,12277],0); -ELEMENTS[36242] = Fluid3D([10468,11172,10497,10155],0); -ELEMENTS[36243] = Fluid3D([16136,15664,16213,15749],0); -ELEMENTS[36244] = Fluid3D([2463,2516,2312,2561],0); -ELEMENTS[36245] = Fluid3D([8228,7775,7153,7090],0); -ELEMENTS[36246] = Fluid3D([13427,12720,12714,12940],0); -ELEMENTS[36247] = Fluid3D([13427,12720,12940,12849],0); -ELEMENTS[36248] = Fluid3D([12720,12940,12849,12102],0); -ELEMENTS[36249] = Fluid3D([12940,12849,12102,12016],0); -ELEMENTS[36250] = Fluid3D([12720,12940,12102,12016],0); -ELEMENTS[36251] = Fluid3D([12849,12720,12102,11423],0); -ELEMENTS[36252] = Fluid3D([12720,12714,12940,12016],0); -ELEMENTS[36253] = Fluid3D([15333,15426,14914,14796],0); -ELEMENTS[36254] = Fluid3D([15426,14914,14796,14982],0); -ELEMENTS[36255] = Fluid3D([15426,14914,14982,15801],0); -ELEMENTS[36256] = Fluid3D([8740,8154,8927,8833],0); -ELEMENTS[36257] = Fluid3D([8740,8154,8833,9044],0); -ELEMENTS[36258] = Fluid3D([8154,8927,8833,8739],0); -ELEMENTS[36259] = Fluid3D([8927,8740,8833,9822],0); -ELEMENTS[36260] = Fluid3D([8154,8833,9044,8604],0); -ELEMENTS[36261] = Fluid3D([8833,8740,9044,9508],0); -ELEMENTS[36262] = Fluid3D([14133,13743,14488,14482],0); -ELEMENTS[36263] = Fluid3D([8687,9667,9352,9566],0); -ELEMENTS[36264] = Fluid3D([5675,6021,6218,6393],0); -ELEMENTS[36265] = Fluid3D([6021,6218,6393,6636],0); -ELEMENTS[36266] = Fluid3D([6393,6021,6636,6306],0); -ELEMENTS[36267] = Fluid3D([17067,16607,16961,16652],0); -ELEMENTS[36268] = Fluid3D([17067,16607,16652,16852],0); -ELEMENTS[36269] = Fluid3D([9431,9458,10455,10169],0); -ELEMENTS[36270] = Fluid3D([13438,13789,14056,13341],0); -ELEMENTS[36271] = Fluid3D([4926,5053,5572,4840],0); -ELEMENTS[36272] = Fluid3D([6691,6355,6660,5855],0); -ELEMENTS[36273] = Fluid3D([18065,17855,17858,17896],0); -ELEMENTS[36274] = Fluid3D([13363,13654,13442,12594],0); -ELEMENTS[36275] = Fluid3D([14368,14805,14752,15120],0); -ELEMENTS[36276] = Fluid3D([15577,16071,15590,15892],0); -ELEMENTS[36277] = Fluid3D([8281,8990,8176,9183],0); -ELEMENTS[36278] = Fluid3D([8176,8281,9183,8428],0); -ELEMENTS[36279] = Fluid3D([8281,9183,8428,8990],0); -ELEMENTS[36280] = Fluid3D([8273,7586,8427,8362],0); -ELEMENTS[36281] = Fluid3D([8273,7586,8362,8070],0); -ELEMENTS[36282] = Fluid3D([8362,8273,8070,9153],0); -ELEMENTS[36283] = Fluid3D([8427,8273,8362,9467],0); -ELEMENTS[36284] = Fluid3D([4345,4660,4185,4419],0); -ELEMENTS[36285] = Fluid3D([13035,12462,13190,12550],0); -ELEMENTS[36286] = Fluid3D([13035,12462,12550,11876],0); -ELEMENTS[36287] = Fluid3D([13190,13035,12550,12721],0); -ELEMENTS[36288] = Fluid3D([13035,12550,12721,12654],0); -ELEMENTS[36289] = Fluid3D([12550,12721,12654,11876],0); -ELEMENTS[36290] = Fluid3D([12550,12721,11876,11220],0); -ELEMENTS[36291] = Fluid3D([12550,13190,12721,12234],0); -ELEMENTS[36292] = Fluid3D([10017,9845,9505,8936],0); -ELEMENTS[36293] = Fluid3D([2673,2949,2598,2910],0); -ELEMENTS[36294] = Fluid3D([15253,14858,15472,15032],0); -ELEMENTS[36295] = Fluid3D([14858,15472,15032,15283],0); -ELEMENTS[36296] = Fluid3D([15253,14858,15032,14800],0); -ELEMENTS[36297] = Fluid3D([15032,14858,15283,14027],0); -ELEMENTS[36298] = Fluid3D([14858,15032,14800,14283],0); -ELEMENTS[36299] = Fluid3D([14858,15032,14283,14027],0); -ELEMENTS[36300] = Fluid3D([15032,14800,14283,14558],0); -ELEMENTS[36301] = Fluid3D([14283,15032,14558,14027],0); -ELEMENTS[36302] = Fluid3D([14800,14858,14283,14584],0); -ELEMENTS[36303] = Fluid3D([14858,14283,14584,13566],0); -ELEMENTS[36304] = Fluid3D([14283,14800,14584,14099],0); -ELEMENTS[36305] = Fluid3D([14283,14800,14099,14558],0); -ELEMENTS[36306] = Fluid3D([14800,14584,14099,14551],0); -ELEMENTS[36307] = Fluid3D([13787,13220,12859,13747],0); -ELEMENTS[36308] = Fluid3D([17061,17305,17364,17103],0); -ELEMENTS[36309] = Fluid3D([17061,17305,17103,16859],0); -ELEMENTS[36310] = Fluid3D([17103,17061,16859,16691],0); -ELEMENTS[36311] = Fluid3D([17103,17061,16691,16873],0); -ELEMENTS[36312] = Fluid3D([5652,5959,6305,5522],0); -ELEMENTS[36313] = Fluid3D([18222,18187,18369,18255],0); -ELEMENTS[36314] = Fluid3D([18187,18369,18255,18209],0); -ELEMENTS[36315] = Fluid3D([18187,18369,18209,18339],0); -ELEMENTS[36316] = Fluid3D([5241,5296,5649,5834],0); -ELEMENTS[36317] = Fluid3D([5241,5296,5834,5364],0); -ELEMENTS[36318] = Fluid3D([5241,5296,5364,4874],0); -ELEMENTS[36319] = Fluid3D([5834,5241,5364,5428],0); -ELEMENTS[36320] = Fluid3D([5364,5241,4874,5428],0); -ELEMENTS[36321] = Fluid3D([4874,5364,5428,5078],0); -ELEMENTS[36322] = Fluid3D([5296,5834,5364,5863],0); -ELEMENTS[36323] = Fluid3D([12200,11316,11197,11890],0); -ELEMENTS[36324] = Fluid3D([9707,9834,9093,10153],0); -ELEMENTS[36325] = Fluid3D([18029,18198,17951,17786],0); -ELEMENTS[36326] = Fluid3D([16875,16472,16696,16800],0); -ELEMENTS[36327] = Fluid3D([4952,4359,4694,4843],0); -ELEMENTS[36328] = Fluid3D([17320,17664,17313,17534],0); -ELEMENTS[36329] = Fluid3D([17313,17320,17534,17155],0); -ELEMENTS[36330] = Fluid3D([17313,17320,17155,16750],0); -ELEMENTS[36331] = Fluid3D([17534,17313,17155,17293],0); -ELEMENTS[36332] = Fluid3D([17155,17534,17293,17431],0); -ELEMENTS[36333] = Fluid3D([17534,17293,17431,17769],0); -ELEMENTS[36334] = Fluid3D([17431,17534,17769,17884],0); -ELEMENTS[36335] = Fluid3D([17534,17769,17884,17664],0); -ELEMENTS[36336] = Fluid3D([17313,17155,17293,16719],0); -ELEMENTS[36337] = Fluid3D([17293,17155,17431,17031],0); -ELEMENTS[36338] = Fluid3D([17320,17534,17155,17431],0); -ELEMENTS[36339] = Fluid3D([17534,17293,17769,17313],0); -ELEMENTS[36340] = Fluid3D([17664,17313,17534,17769],0); -ELEMENTS[36341] = Fluid3D([16652,16919,17067,16852],0); -ELEMENTS[36342] = Fluid3D([6147,6273,5695,6258],0); -ELEMENTS[36343] = Fluid3D([6147,6273,6258,6778],0); -ELEMENTS[36344] = Fluid3D([6147,6273,6778,6897],0); -ELEMENTS[36345] = Fluid3D([6778,6147,6897,6365],0); -ELEMENTS[36346] = Fluid3D([6273,6258,6778,7212],0); -ELEMENTS[36347] = Fluid3D([6778,6273,7212,6897],0); -ELEMENTS[36348] = Fluid3D([7212,6778,6897,7091],0); -ELEMENTS[36349] = Fluid3D([7212,6778,7091,6258],0); -ELEMENTS[36350] = Fluid3D([6778,6897,7091,6365],0); -ELEMENTS[36351] = Fluid3D([6778,7091,6258,6365],0); -ELEMENTS[36352] = Fluid3D([6778,6147,6365,6258],0); -ELEMENTS[36353] = Fluid3D([6147,6365,6258,5695],0); -ELEMENTS[36354] = Fluid3D([6147,6365,5695,5794],0); -ELEMENTS[36355] = Fluid3D([6147,6897,6365,5945],0); -ELEMENTS[36356] = Fluid3D([5061,4912,4504,4784],0); -ELEMENTS[36357] = Fluid3D([11840,12275,11917,12331],0); -ELEMENTS[36358] = Fluid3D([16482,16003,15814,16331],0); -ELEMENTS[36359] = Fluid3D([15814,16482,16331,16590],0); -ELEMENTS[36360] = Fluid3D([12039,11034,11306,12218],0); -ELEMENTS[36361] = Fluid3D([2420,2606,2715,2465],0); -ELEMENTS[36362] = Fluid3D([2715,2420,2465,2705],0); -ELEMENTS[36363] = Fluid3D([2465,2715,2705,2927],0); -ELEMENTS[36364] = Fluid3D([2420,2606,2465,2261],0); -ELEMENTS[36365] = Fluid3D([2606,2715,2465,2927],0); -ELEMENTS[36366] = Fluid3D([2715,2420,2705,2564],0); -ELEMENTS[36367] = Fluid3D([6739,6615,6528,5777],0); -ELEMENTS[36368] = Fluid3D([5926,6225,6810,6337],0); -ELEMENTS[36369] = Fluid3D([5926,6225,6337,5756],0); -ELEMENTS[36370] = Fluid3D([4378,4428,4624,4637],0); -ELEMENTS[36371] = Fluid3D([8999,9385,8692,8858],0); -ELEMENTS[36372] = Fluid3D([17488,17356,17107,17571],0); -ELEMENTS[36373] = Fluid3D([2666,2640,2442,2414],0); -ELEMENTS[36374] = Fluid3D([18078,18153,18158,17938],0); -ELEMENTS[36375] = Fluid3D([16141,15688,15731,15921],0); -ELEMENTS[36376] = Fluid3D([9070,9593,9047,8817],0); -ELEMENTS[36377] = Fluid3D([4803,4887,5032,4496],0); -ELEMENTS[36378] = Fluid3D([4803,4887,4496,4552],0); -ELEMENTS[36379] = Fluid3D([4803,4887,4552,4907],0); -ELEMENTS[36380] = Fluid3D([4496,4803,4552,4147],0); -ELEMENTS[36381] = Fluid3D([4496,4803,4147,4645],0); -ELEMENTS[36382] = Fluid3D([4496,4803,4645,5032],0); -ELEMENTS[36383] = Fluid3D([8846,8793,9466,9152],0); -ELEMENTS[36384] = Fluid3D([11187,11571,10564,10606],0); -ELEMENTS[36385] = Fluid3D([18392,18460,18512,18564],0); -ELEMENTS[36386] = Fluid3D([9338,9219,9885,8633],0); -ELEMENTS[36387] = Fluid3D([11546,10602,10746,10384],0); -ELEMENTS[36388] = Fluid3D([13004,13059,13158,12195],0); -ELEMENTS[36389] = Fluid3D([14575,14691,15193,15502],0); -ELEMENTS[36390] = Fluid3D([3462,3855,3622,4034],0); -ELEMENTS[36391] = Fluid3D([8013,8712,7641,8483],0); -ELEMENTS[36392] = Fluid3D([7641,8013,8483,7573],0); -ELEMENTS[36393] = Fluid3D([7641,8013,7573,7413],0); -ELEMENTS[36394] = Fluid3D([7641,8013,7413,8396],0); -ELEMENTS[36395] = Fluid3D([8013,7573,7413,8483],0); -ELEMENTS[36396] = Fluid3D([15371,15798,15479,15252],0); -ELEMENTS[36397] = Fluid3D([2337,2572,2385,2384],0); -ELEMENTS[36398] = Fluid3D([14330,14540,13955,14444],0); -ELEMENTS[36399] = Fluid3D([12196,12065,12466,12958],0); -ELEMENTS[36400] = Fluid3D([12196,12065,12958,12699],0); -ELEMENTS[36401] = Fluid3D([12466,12196,12958,12519],0); -ELEMENTS[36402] = Fluid3D([12958,12196,12699,13210],0); -ELEMENTS[36403] = Fluid3D([10210,10442,9517,10361],0); -ELEMENTS[36404] = Fluid3D([3890,3507,3730,3797],0); -ELEMENTS[36405] = Fluid3D([14087,14656,14437,15015],0); -ELEMENTS[36406] = Fluid3D([6553,6532,7112,6372],0); -ELEMENTS[36407] = Fluid3D([9473,8874,9313,10193],0); -ELEMENTS[36408] = Fluid3D([11534,11590,11815,12393],0); -ELEMENTS[36409] = Fluid3D([11815,11534,12393,12260],0); -ELEMENTS[36410] = Fluid3D([11815,11534,12260,11044],0); -ELEMENTS[36411] = Fluid3D([11534,11590,12393,11707],0); -ELEMENTS[36412] = Fluid3D([11534,12393,12260,11979],0); -ELEMENTS[36413] = Fluid3D([3517,3236,3180,3191],0); -ELEMENTS[36414] = Fluid3D([4579,5068,4478,4920],0); -ELEMENTS[36415] = Fluid3D([9781,9956,9189,10399],0); -ELEMENTS[36416] = Fluid3D([9781,9956,10399,11105],0); -ELEMENTS[36417] = Fluid3D([9956,9189,10399,9572],0); -ELEMENTS[36418] = Fluid3D([18029,18309,18198,18179],0); -ELEMENTS[36419] = Fluid3D([18029,18309,18179,17802],0); -ELEMENTS[36420] = Fluid3D([8376,7881,8128,7330],0); -ELEMENTS[36421] = Fluid3D([17429,17593,17123,17283],0); -ELEMENTS[36422] = Fluid3D([17123,17429,17283,17168],0); -ELEMENTS[36423] = Fluid3D([15289,15382,15742,15034],0); -ELEMENTS[36424] = Fluid3D([3899,3785,3995,4330],0); -ELEMENTS[36425] = Fluid3D([6012,6467,6348,6043],0); -ELEMENTS[36426] = Fluid3D([13981,14857,14254,14511],0); -ELEMENTS[36427] = Fluid3D([15634,15144,15268,15081],0); -ELEMENTS[36428] = Fluid3D([4804,4613,4165,4284],0); -ELEMENTS[36429] = Fluid3D([17325,17599,17328,17310],0); -ELEMENTS[36430] = Fluid3D([13264,12382,13566,13177],0); -ELEMENTS[36431] = Fluid3D([17215,17100,16904,17359],0); -ELEMENTS[36432] = Fluid3D([18620,18640,18673,18654],0); -ELEMENTS[36433] = Fluid3D([18640,18673,18654,18681],0); -ELEMENTS[36434] = Fluid3D([18654,18640,18681,18653],0); -ELEMENTS[36435] = Fluid3D([18640,18681,18653,18650],0); -ELEMENTS[36436] = Fluid3D([18654,18640,18653,18571],0); -ELEMENTS[36437] = Fluid3D([18681,18654,18653,18664],0); -ELEMENTS[36438] = Fluid3D([18653,18681,18664,18689],0); -ELEMENTS[36439] = Fluid3D([18654,18653,18664,18617],0); -ELEMENTS[36440] = Fluid3D([18653,18664,18617,18651],0); -ELEMENTS[36441] = Fluid3D([18653,18664,18651,18689],0); -ELEMENTS[36442] = Fluid3D([18664,18617,18651,18644],0); -ELEMENTS[36443] = Fluid3D([18664,18617,18644,18622],0); -ELEMENTS[36444] = Fluid3D([18664,18617,18622,18654],0); -ELEMENTS[36445] = Fluid3D([18617,18644,18622,18591],0); -ELEMENTS[36446] = Fluid3D([18654,18640,18571,18620],0); -ELEMENTS[36447] = Fluid3D([14910,14482,14133,14488],0); -ELEMENTS[36448] = Fluid3D([5128,4747,5340,5484],0); -ELEMENTS[36449] = Fluid3D([6969,7492,6750,6900],0); -ELEMENTS[36450] = Fluid3D([6969,7492,6900,6706],0); -ELEMENTS[36451] = Fluid3D([10486,11389,10952,11684],0); -ELEMENTS[36452] = Fluid3D([5313,4902,5423,5278],0); -ELEMENTS[36453] = Fluid3D([14835,15455,14799,14855],0); -ELEMENTS[36454] = Fluid3D([14835,15455,14855,15339],0); -ELEMENTS[36455] = Fluid3D([14855,14835,15339,14327],0); -ELEMENTS[36456] = Fluid3D([14855,14835,14327,14286],0); -ELEMENTS[36457] = Fluid3D([14835,14327,14286,14319],0); -ELEMENTS[36458] = Fluid3D([14835,14327,14319,14807],0); -ELEMENTS[36459] = Fluid3D([14835,14327,14807,15339],0); -ELEMENTS[36460] = Fluid3D([16341,16320,16415,16810],0); -ELEMENTS[36461] = Fluid3D([16415,16341,16810,16525],0); -ELEMENTS[36462] = Fluid3D([16748,16364,16799,16189],0); -ELEMENTS[36463] = Fluid3D([16364,16799,16189,16226],0); -ELEMENTS[36464] = Fluid3D([16364,16799,16226,16160],0); -ELEMENTS[36465] = Fluid3D([16189,16364,16226,15892],0); -ELEMENTS[36466] = Fluid3D([10231,10271,9871,9127],0); -ELEMENTS[36467] = Fluid3D([8976,8181,8494,9107],0); -ELEMENTS[36468] = Fluid3D([12490,11872,12133,11944],0); -ELEMENTS[36469] = Fluid3D([16964,16597,17109,17185],0); -ELEMENTS[36470] = Fluid3D([17467,17387,17618,17224],0); -ELEMENTS[36471] = Fluid3D([10739,10041,9952,10534],0); -ELEMENTS[36472] = Fluid3D([10739,10041,10534,10970],0); -ELEMENTS[36473] = Fluid3D([10041,9952,10534,10058],0); -ELEMENTS[36474] = Fluid3D([10534,10041,10058,9903],0); -ELEMENTS[36475] = Fluid3D([10534,10041,9903,10970],0); -ELEMENTS[36476] = Fluid3D([9952,10534,10058,11069],0); -ELEMENTS[36477] = Fluid3D([13478,13776,14358,13547],0); -ELEMENTS[36478] = Fluid3D([12108,11505,12048,12172],0); -ELEMENTS[36479] = Fluid3D([5521,6010,6049,6475],0); -ELEMENTS[36480] = Fluid3D([16416,16626,16981,16537],0); -ELEMENTS[36481] = Fluid3D([16626,16981,16537,16710],0); -ELEMENTS[36482] = Fluid3D([16626,16981,16710,16606],0); -ELEMENTS[36483] = Fluid3D([16537,16626,16710,16229],0); -ELEMENTS[36484] = Fluid3D([16416,16626,16537,16229],0); -ELEMENTS[36485] = Fluid3D([10014,9999,10753,10723],0); -ELEMENTS[36486] = Fluid3D([10014,9999,10723,9702],0); -ELEMENTS[36487] = Fluid3D([10904,11553,11001,11618],0); -ELEMENTS[36488] = Fluid3D([16433,15797,16217,16202],0); -ELEMENTS[36489] = Fluid3D([18395,18530,18477,18514],0); -ELEMENTS[36490] = Fluid3D([18477,18395,18514,18423],0); -ELEMENTS[36491] = Fluid3D([18514,18477,18423,18515],0); -ELEMENTS[36492] = Fluid3D([18477,18423,18515,18366],0); -ELEMENTS[36493] = Fluid3D([18477,18423,18366,18202],0); -ELEMENTS[36494] = Fluid3D([18515,18477,18366,18531],0); -ELEMENTS[36495] = Fluid3D([18515,18477,18531,18592],0); -ELEMENTS[36496] = Fluid3D([18423,18515,18366,18281],0); -ELEMENTS[36497] = Fluid3D([18366,18423,18281,18202],0); -ELEMENTS[36498] = Fluid3D([18281,18366,18202,18135],0); -ELEMENTS[36499] = Fluid3D([18515,18477,18592,18514],0); -ELEMENTS[36500] = Fluid3D([18395,18514,18423,18400],0); -ELEMENTS[36501] = Fluid3D([18395,18514,18400,18530],0); -ELEMENTS[36502] = Fluid3D([18477,18395,18423,18228],0); -ELEMENTS[36503] = Fluid3D([18477,18592,18514,18530],0); -ELEMENTS[36504] = Fluid3D([18477,18531,18592,18530],0); -ELEMENTS[36505] = Fluid3D([13193,13780,13232,13715],0); -ELEMENTS[36506] = Fluid3D([14766,14819,15070,15597],0); -ELEMENTS[36507] = Fluid3D([8102,8174,8919,8745],0); -ELEMENTS[36508] = Fluid3D([12875,13461,12712,12148],0); -ELEMENTS[36509] = Fluid3D([9255,8323,9191,8882],0); -ELEMENTS[36510] = Fluid3D([9191,9255,8882,10185],0); -ELEMENTS[36511] = Fluid3D([9255,8323,8882,8379],0); -ELEMENTS[36512] = Fluid3D([11648,11816,11704,11398],0); -ELEMENTS[36513] = Fluid3D([4700,4580,4662,5206],0); -ELEMENTS[36514] = Fluid3D([14434,14251,14193,13473],0); -ELEMENTS[36515] = Fluid3D([4532,4354,4680,4198],0); -ELEMENTS[36516] = Fluid3D([4532,4354,4198,3888],0); -ELEMENTS[36517] = Fluid3D([13427,13783,12940,12714],0); -ELEMENTS[36518] = Fluid3D([7818,7872,8549,7934],0); -ELEMENTS[36519] = Fluid3D([6254,6822,7089,6571],0); -ELEMENTS[36520] = Fluid3D([14771,14659,15176,15235],0); -ELEMENTS[36521] = Fluid3D([15176,14771,15235,14990],0); -ELEMENTS[36522] = Fluid3D([15176,14771,14990,14683],0); -ELEMENTS[36523] = Fluid3D([14771,14659,15235,15040],0); -ELEMENTS[36524] = Fluid3D([17973,17641,17866,17726],0); -ELEMENTS[36525] = Fluid3D([17641,17866,17726,17606],0); -ELEMENTS[36526] = Fluid3D([2214,2482,2422,2367],0); -ELEMENTS[36527] = Fluid3D([2482,2422,2367,2647],0); -ELEMENTS[36528] = Fluid3D([2482,2422,2647,2739],0); -ELEMENTS[36529] = Fluid3D([2367,2482,2647,2602],0); -ELEMENTS[36530] = Fluid3D([2422,2647,2739,2534],0); -ELEMENTS[36531] = Fluid3D([2647,2739,2534,2745],0); -ELEMENTS[36532] = Fluid3D([2534,2647,2745,2484],0); -ELEMENTS[36533] = Fluid3D([2647,2745,2484,2849],0); -ELEMENTS[36534] = Fluid3D([2745,2534,2484,2638],0); -ELEMENTS[36535] = Fluid3D([2745,2534,2638,2592],0); -ELEMENTS[36536] = Fluid3D([2534,2638,2592,2326],0); -ELEMENTS[36537] = Fluid3D([2592,2534,2326,2422],0); -ELEMENTS[36538] = Fluid3D([2534,2638,2326,2484],0); -ELEMENTS[36539] = Fluid3D([2647,2739,2745,2970],0); -ELEMENTS[36540] = Fluid3D([2745,2647,2970,2849],0); -ELEMENTS[36541] = Fluid3D([2647,2739,2970,2800],0); -ELEMENTS[36542] = Fluid3D([2534,2647,2484,2422],0); -ELEMENTS[36543] = Fluid3D([2534,2326,2422,2484],0); -ELEMENTS[36544] = Fluid3D([2214,2482,2367,2257],0); -ELEMENTS[36545] = Fluid3D([2422,2367,2647,2484],0); -ELEMENTS[36546] = Fluid3D([2367,2647,2484,2502],0); -ELEMENTS[36547] = Fluid3D([2484,2367,2502,2210],0); -ELEMENTS[36548] = Fluid3D([2647,2484,2502,2849],0); -ELEMENTS[36549] = Fluid3D([2367,2502,2210,2257],0); -ELEMENTS[36550] = Fluid3D([2484,2367,2210,2326],0); -ELEMENTS[36551] = Fluid3D([2367,2647,2502,2602],0); -ELEMENTS[36552] = Fluid3D([2502,2484,2210,2413],0); -ELEMENTS[36553] = Fluid3D([2502,2484,2413,2748],0); -ELEMENTS[36554] = Fluid3D([2502,2484,2748,2849],0); -ELEMENTS[36555] = Fluid3D([2484,2413,2748,2638],0); -ELEMENTS[36556] = Fluid3D([2484,2210,2413,2256],0); -ELEMENTS[36557] = Fluid3D([2413,2484,2256,2638],0); -ELEMENTS[36558] = Fluid3D([12562,13026,13632,12569],0); -ELEMENTS[36559] = Fluid3D([10174,10224,9438,9574],0); -ELEMENTS[36560] = Fluid3D([9438,10174,9574,9391],0); -ELEMENTS[36561] = Fluid3D([9438,10174,9391,10435],0); -ELEMENTS[36562] = Fluid3D([17227,17136,16900,17469],0); -ELEMENTS[36563] = Fluid3D([17227,17136,17469,17721],0); -ELEMENTS[36564] = Fluid3D([11076,10955,10360,9927],0); -ELEMENTS[36565] = Fluid3D([5472,5302,5094,4883],0); -ELEMENTS[36566] = Fluid3D([15486,16008,16109,15992],0); -ELEMENTS[36567] = Fluid3D([15721,15986,15878,15403],0); -ELEMENTS[36568] = Fluid3D([16427,16692,16812,17115],0); -ELEMENTS[36569] = Fluid3D([2717,3035,2798,2703],0); -ELEMENTS[36570] = Fluid3D([2798,2717,2703,2366],0); -ELEMENTS[36571] = Fluid3D([2717,3035,2703,2728],0); -ELEMENTS[36572] = Fluid3D([2703,2717,2728,2415],0); -ELEMENTS[36573] = Fluid3D([11948,11518,11932,12425],0); -ELEMENTS[36574] = Fluid3D([3222,3108,3141,2858],0); -ELEMENTS[36575] = Fluid3D([17687,17643,17896,17858],0); -ELEMENTS[36576] = Fluid3D([7302,8144,8285,7674],0); -ELEMENTS[36577] = Fluid3D([4746,4251,4195,4307],0); -ELEMENTS[36578] = Fluid3D([4432,4110,4057,4641],0); -ELEMENTS[36579] = Fluid3D([3507,3182,3074,3730],0); -ELEMENTS[36580] = Fluid3D([3507,3182,3730,3797],0); -ELEMENTS[36581] = Fluid3D([18550,18458,18576,18597],0); -ELEMENTS[36582] = Fluid3D([18576,18550,18597,18636],0); -ELEMENTS[36583] = Fluid3D([18550,18597,18636,18646],0); -ELEMENTS[36584] = Fluid3D([16110,15531,16063,16054],0); -ELEMENTS[36585] = Fluid3D([16063,16110,16054,16765],0); -ELEMENTS[36586] = Fluid3D([16110,15531,16054,15513],0); -ELEMENTS[36587] = Fluid3D([16054,16110,15513,16179],0); -ELEMENTS[36588] = Fluid3D([16054,16110,16179,16765],0); -ELEMENTS[36589] = Fluid3D([16110,15513,16179,15947],0); -ELEMENTS[36590] = Fluid3D([12233,11737,11762,12737],0); -ELEMENTS[36591] = Fluid3D([15031,15452,15441,14859],0); -ELEMENTS[36592] = Fluid3D([15031,15452,14859,15428],0); -ELEMENTS[36593] = Fluid3D([16579,16855,16514,16405],0); -ELEMENTS[36594] = Fluid3D([8338,7804,7741,7277],0); -ELEMENTS[36595] = Fluid3D([7804,7741,7277,7969],0); -ELEMENTS[36596] = Fluid3D([7741,8338,7277,8311],0); -ELEMENTS[36597] = Fluid3D([8338,7804,7277,7591],0); -ELEMENTS[36598] = Fluid3D([7741,7277,7969,7139],0); -ELEMENTS[36599] = Fluid3D([7741,7277,7139,7078],0); -ELEMENTS[36600] = Fluid3D([7804,7277,7591,7342],0); -ELEMENTS[36601] = Fluid3D([7804,7277,7342,6767],0); -ELEMENTS[36602] = Fluid3D([7139,7741,7078,7363],0); -ELEMENTS[36603] = Fluid3D([7078,7139,7363,6572],0); -ELEMENTS[36604] = Fluid3D([7277,7804,7969,7036],0); -ELEMENTS[36605] = Fluid3D([7139,7363,6572,7969],0); -ELEMENTS[36606] = Fluid3D([7969,7741,7139,7363],0); -ELEMENTS[36607] = Fluid3D([14376,14127,14314,14776],0); -ELEMENTS[36608] = Fluid3D([14127,14314,14776,14734],0); -ELEMENTS[36609] = Fluid3D([14376,14127,14776,14833],0); -ELEMENTS[36610] = Fluid3D([10464,10287,10813,11317],0); -ELEMENTS[36611] = Fluid3D([6804,7300,7167,7616],0); -ELEMENTS[36612] = Fluid3D([13390,12877,13776,13295],0); -ELEMENTS[36613] = Fluid3D([12877,13776,13295,13269],0); -ELEMENTS[36614] = Fluid3D([13295,12877,13269,12261],0); -ELEMENTS[36615] = Fluid3D([13776,13295,13269,14085],0); -ELEMENTS[36616] = Fluid3D([2816,2615,2630,2374],0); -ELEMENTS[36617] = Fluid3D([4364,4097,4296,4753],0); -ELEMENTS[36618] = Fluid3D([14211,14112,13535,14427],0); -ELEMENTS[36619] = Fluid3D([10324,10049,9819,9205],0); -ELEMENTS[36620] = Fluid3D([17498,17050,17330,17285],0); -ELEMENTS[36621] = Fluid3D([17050,17330,17285,17158],0); -ELEMENTS[36622] = Fluid3D([8341,8227,9103,8515],0); -ELEMENTS[36623] = Fluid3D([10902,10930,10824,9950],0); -ELEMENTS[36624] = Fluid3D([12897,12279,12707,12356],0); -ELEMENTS[36625] = Fluid3D([13440,13256,13850,14437],0); -ELEMENTS[36626] = Fluid3D([5740,5133,5521,5385],0); -ELEMENTS[36627] = Fluid3D([5319,5207,5033,4653],0); -ELEMENTS[36628] = Fluid3D([10590,9993,9801,10580],0); -ELEMENTS[36629] = Fluid3D([4596,4154,4622,4348],0); -ELEMENTS[36630] = Fluid3D([12048,12280,12916,13017],0); -ELEMENTS[36631] = Fluid3D([12916,12048,13017,12636],0); -ELEMENTS[36632] = Fluid3D([14069,14642,14528,14194],0); -ELEMENTS[36633] = Fluid3D([14069,14642,14194,13947],0); -ELEMENTS[36634] = Fluid3D([15798,14966,15468,15252],0); -ELEMENTS[36635] = Fluid3D([17850,17733,18009,17790],0); -ELEMENTS[36636] = Fluid3D([17420,17199,16969,17170],0); -ELEMENTS[36637] = Fluid3D([17199,16969,17170,16728],0); -ELEMENTS[36638] = Fluid3D([16969,17170,16728,16636],0); -ELEMENTS[36639] = Fluid3D([16969,17170,16636,17109],0); -ELEMENTS[36640] = Fluid3D([16969,17170,17109,17420],0); -ELEMENTS[36641] = Fluid3D([13643,12891,13818,13637],0); -ELEMENTS[36642] = Fluid3D([13818,13643,13637,14604],0); -ELEMENTS[36643] = Fluid3D([13643,12891,13637,12714],0); -ELEMENTS[36644] = Fluid3D([7553,6980,7769,7869],0); -ELEMENTS[36645] = Fluid3D([2793,2493,2401,2598],0); -ELEMENTS[36646] = Fluid3D([14775,15119,14337,15097],0); -ELEMENTS[36647] = Fluid3D([2745,2904,2748,3127],0); -ELEMENTS[36648] = Fluid3D([10652,11545,10981,11628],0); -ELEMENTS[36649] = Fluid3D([17003,17353,17305,17204],0); -ELEMENTS[36650] = Fluid3D([5121,5591,5447,5796],0); -ELEMENTS[36651] = Fluid3D([8044,8502,8491,7487],0); -ELEMENTS[36652] = Fluid3D([6939,6207,5942,6715],0); -ELEMENTS[36653] = Fluid3D([7158,7106,6987,6316],0); -ELEMENTS[36654] = Fluid3D([5609,5398,5818,6030],0); -ELEMENTS[36655] = Fluid3D([14517,14825,14250,14817],0); -ELEMENTS[36656] = Fluid3D([10664,11425,10918,11080],0); -ELEMENTS[36657] = Fluid3D([10664,11425,11080,11795],0); -ELEMENTS[36658] = Fluid3D([11425,10918,11080,12034],0); -ELEMENTS[36659] = Fluid3D([11425,11080,11795,12034],0); -ELEMENTS[36660] = Fluid3D([2385,2337,2384,2109],0); -ELEMENTS[36661] = Fluid3D([13934,14400,14783,14658],0); -ELEMENTS[36662] = Fluid3D([4212,3954,3805,4494],0); -ELEMENTS[36663] = Fluid3D([15039,14222,14604,14996],0); -ELEMENTS[36664] = Fluid3D([4778,4997,5099,5315],0); -ELEMENTS[36665] = Fluid3D([8197,8890,8829,7994],0); -ELEMENTS[36666] = Fluid3D([14566,14644,14532,14984],0); -ELEMENTS[36667] = Fluid3D([14566,14644,14984,15088],0); -ELEMENTS[36668] = Fluid3D([14566,14644,15088,14768],0); -ELEMENTS[36669] = Fluid3D([14984,14566,15088,15418],0); -ELEMENTS[36670] = Fluid3D([14364,14767,13984,13735],0); -ELEMENTS[36671] = Fluid3D([13205,12335,12639,13252],0); -ELEMENTS[36672] = Fluid3D([3392,3273,3949,3497],0); -ELEMENTS[36673] = Fluid3D([3392,3273,3497,3026],0); -ELEMENTS[36674] = Fluid3D([18022,18082,18260,18210],0); -ELEMENTS[36675] = Fluid3D([5408,5348,5209,5719],0); -ELEMENTS[36676] = Fluid3D([4601,4557,4975,4765],0); -ELEMENTS[36677] = Fluid3D([17396,17699,17758,17954],0); -ELEMENTS[36678] = Fluid3D([12462,12550,11876,12037],0); -ELEMENTS[36679] = Fluid3D([13764,13997,14811,14421],0); -ELEMENTS[36680] = Fluid3D([6471,6939,5942,6715],0); -ELEMENTS[36681] = Fluid3D([14945,15109,14396,14117],0); -ELEMENTS[36682] = Fluid3D([3954,4275,3797,3890],0); -ELEMENTS[36683] = Fluid3D([10154,10068,11002,10712],0); -ELEMENTS[36684] = Fluid3D([13870,14206,14462,13530],0); -ELEMENTS[36685] = Fluid3D([15570,15505,15455,16016],0); -ELEMENTS[36686] = Fluid3D([15570,15505,16016,15697],0); -ELEMENTS[36687] = Fluid3D([15455,15570,16016,15538],0); -ELEMENTS[36688] = Fluid3D([15455,15570,15538,14799],0); -ELEMENTS[36689] = Fluid3D([15570,16016,15538,16095],0); -ELEMENTS[36690] = Fluid3D([16016,15570,15697,16371],0); -ELEMENTS[36691] = Fluid3D([3986,4113,4160,3874],0); -ELEMENTS[36692] = Fluid3D([9846,9567,9443,10550],0); -ELEMENTS[36693] = Fluid3D([6738,7467,6885,6772],0); -ELEMENTS[36694] = Fluid3D([17743,17839,17515,17787],0); -ELEMENTS[36695] = Fluid3D([7644,7307,8188,8103],0); -ELEMENTS[36696] = Fluid3D([3505,3172,3473,3512],0); -ELEMENTS[36697] = Fluid3D([3473,3505,3512,3741],0); -ELEMENTS[36698] = Fluid3D([3512,3473,3741,3281],0); -ELEMENTS[36699] = Fluid3D([3741,3512,3281,3622],0); -ELEMENTS[36700] = Fluid3D([3512,3281,3622,3462],0); -ELEMENTS[36701] = Fluid3D([3741,3512,3622,4291],0); -ELEMENTS[36702] = Fluid3D([9474,8648,9597,8997],0); -ELEMENTS[36703] = Fluid3D([3720,3893,3671,3639],0); -ELEMENTS[36704] = Fluid3D([15402,14953,15805,15396],0); -ELEMENTS[36705] = Fluid3D([14690,14183,14473,14964],0); -ELEMENTS[36706] = Fluid3D([14690,14183,14964,15149],0); -ELEMENTS[36707] = Fluid3D([12037,12021,11322,12462],0); -ELEMENTS[36708] = Fluid3D([17002,16755,17254,16976],0); -ELEMENTS[36709] = Fluid3D([13389,12953,13914,13680],0); -ELEMENTS[36710] = Fluid3D([13826,14415,13406,13797],0); -ELEMENTS[36711] = Fluid3D([13406,13826,13797,12962],0); -ELEMENTS[36712] = Fluid3D([13406,13826,12962,12746],0); -ELEMENTS[36713] = Fluid3D([13826,13797,12962,13573],0); -ELEMENTS[36714] = Fluid3D([13826,13797,13573,14078],0); -ELEMENTS[36715] = Fluid3D([13797,13573,14078,13882],0); -ELEMENTS[36716] = Fluid3D([14078,13797,13882,14795],0); -ELEMENTS[36717] = Fluid3D([12962,13826,13573,13137],0); -ELEMENTS[36718] = Fluid3D([12962,13826,13137,12746],0); -ELEMENTS[36719] = Fluid3D([13826,13573,13137,13841],0); -ELEMENTS[36720] = Fluid3D([13826,13573,13841,14078],0); -ELEMENTS[36721] = Fluid3D([13573,13841,14078,14085],0); -ELEMENTS[36722] = Fluid3D([13573,12962,13137,12255],0); -ELEMENTS[36723] = Fluid3D([13797,12962,13573,13211],0); -ELEMENTS[36724] = Fluid3D([13573,13797,13211,13882],0); -ELEMENTS[36725] = Fluid3D([13797,13211,13882,13273],0); -ELEMENTS[36726] = Fluid3D([12962,13573,13211,12255],0); -ELEMENTS[36727] = Fluid3D([13826,14415,13797,14078],0); -ELEMENTS[36728] = Fluid3D([14415,13797,14078,14795],0); -ELEMENTS[36729] = Fluid3D([13797,12962,13211,12769],0); -ELEMENTS[36730] = Fluid3D([12962,13211,12769,11946],0); -ELEMENTS[36731] = Fluid3D([13797,12962,12769,13406],0); -ELEMENTS[36732] = Fluid3D([12962,12769,13406,12696],0); -ELEMENTS[36733] = Fluid3D([13573,13137,13841,12994],0); -ELEMENTS[36734] = Fluid3D([13841,13573,12994,13269],0); -ELEMENTS[36735] = Fluid3D([13841,13573,13269,14085],0); -ELEMENTS[36736] = Fluid3D([13573,12994,13269,12255],0); -ELEMENTS[36737] = Fluid3D([12769,12962,11946,12112],0); -ELEMENTS[36738] = Fluid3D([9403,8699,9011,8406],0); -ELEMENTS[36739] = Fluid3D([8699,9011,8406,7966],0); -ELEMENTS[36740] = Fluid3D([9403,8699,8406,8832],0); -ELEMENTS[36741] = Fluid3D([12810,12317,13299,12299],0); -ELEMENTS[36742] = Fluid3D([15662,15498,16244,15741],0); -ELEMENTS[36743] = Fluid3D([13178,13323,13687,13048],0); -ELEMENTS[36744] = Fluid3D([17803,17966,17930,17793],0); -ELEMENTS[36745] = Fluid3D([9140,8776,8840,9590],0); -ELEMENTS[36746] = Fluid3D([3420,3379,3564,3782],0); -ELEMENTS[36747] = Fluid3D([3564,3420,3782,3659],0); -ELEMENTS[36748] = Fluid3D([14597,15092,15360,14697],0); -ELEMENTS[36749] = Fluid3D([14597,15092,14697,14226],0); -ELEMENTS[36750] = Fluid3D([14697,14597,14226,14437],0); -ELEMENTS[36751] = Fluid3D([17105,16706,16956,16925],0); -ELEMENTS[36752] = Fluid3D([16706,16956,16925,16405],0); -ELEMENTS[36753] = Fluid3D([10069,9849,10563,10847],0); -ELEMENTS[36754] = Fluid3D([4556,4646,4482,5129],0); -ELEMENTS[36755] = Fluid3D([15172,14671,15041,15216],0); -ELEMENTS[36756] = Fluid3D([13068,12241,12945,12972],0); -ELEMENTS[36757] = Fluid3D([9415,8517,8414,8911],0); -ELEMENTS[36758] = Fluid3D([13593,14495,13948,14559],0); -ELEMENTS[36759] = Fluid3D([10666,10564,10004,11542],0); -ELEMENTS[36760] = Fluid3D([8459,8399,8498,9400],0); -ELEMENTS[36761] = Fluid3D([10199,9648,10345,11120],0); -ELEMENTS[36762] = Fluid3D([15971,15975,15794,16379],0); -ELEMENTS[36763] = Fluid3D([14250,14912,14817,14825],0); -ELEMENTS[36764] = Fluid3D([12880,12658,12123,12756],0); -ELEMENTS[36765] = Fluid3D([2280,2402,2123,2317],0); -ELEMENTS[36766] = Fluid3D([2280,2402,2317,2511],0); -ELEMENTS[36767] = Fluid3D([2288,2243,2094,2276],0); -ELEMENTS[36768] = Fluid3D([17527,17683,17846,17628],0); -ELEMENTS[36769] = Fluid3D([14050,14758,14476,14586],0); -ELEMENTS[36770] = Fluid3D([14050,14758,14586,13682],0); -ELEMENTS[36771] = Fluid3D([14476,14050,14586,13986],0); -ELEMENTS[36772] = Fluid3D([7252,7804,6767,7036],0); -ELEMENTS[36773] = Fluid3D([13565,13693,14366,14596],0); -ELEMENTS[36774] = Fluid3D([9673,10229,9367,10339],0); -ELEMENTS[36775] = Fluid3D([9673,10229,10339,10664],0); -ELEMENTS[36776] = Fluid3D([3152,3343,3523,3242],0); -ELEMENTS[36777] = Fluid3D([3152,3343,3242,2900],0); -ELEMENTS[36778] = Fluid3D([3152,3343,2900,2836],0); -ELEMENTS[36779] = Fluid3D([10859,10965,10042,11009],0); -ELEMENTS[36780] = Fluid3D([17775,17683,17862,18043],0); -ELEMENTS[36781] = Fluid3D([12448,11349,11415,12000],0); -ELEMENTS[36782] = Fluid3D([11349,11415,12000,10937],0); -ELEMENTS[36783] = Fluid3D([4302,4968,5005,4385],0); -ELEMENTS[36784] = Fluid3D([14452,14626,14000,13766],0); -ELEMENTS[36785] = Fluid3D([12502,13101,13001,13433],0); -ELEMENTS[36786] = Fluid3D([10837,10333,10388,9638],0); -ELEMENTS[36787] = Fluid3D([6859,7555,6755,7041],0); -ELEMENTS[36788] = Fluid3D([16317,16432,16287,16756],0); -ELEMENTS[36789] = Fluid3D([6153,5669,5778,5367],0); -ELEMENTS[36790] = Fluid3D([9676,10435,10772,9442],0); -ELEMENTS[36791] = Fluid3D([18044,17875,18200,18240],0); -ELEMENTS[36792] = Fluid3D([16914,17151,16985,17001],0); -ELEMENTS[36793] = Fluid3D([16985,16914,17001,16505],0); -ELEMENTS[36794] = Fluid3D([16914,17001,16505,16727],0); -ELEMENTS[36795] = Fluid3D([16914,17151,17001,17344],0); -ELEMENTS[36796] = Fluid3D([9567,9410,9474,10599],0); -ELEMENTS[36797] = Fluid3D([6191,6894,7158,6757],0); -ELEMENTS[36798] = Fluid3D([6894,7158,6757,7627],0); -ELEMENTS[36799] = Fluid3D([16285,15858,15616,15981],0); -ELEMENTS[36800] = Fluid3D([14697,14390,14226,14032],0); -ELEMENTS[36801] = Fluid3D([14226,14697,14032,14685],0); -ELEMENTS[36802] = Fluid3D([11985,11344,11531,10980],0); -ELEMENTS[36803] = Fluid3D([11985,11344,10980,11054],0); -ELEMENTS[36804] = Fluid3D([11985,11344,11054,11273],0); -ELEMENTS[36805] = Fluid3D([11344,10980,11054,10577],0); -ELEMENTS[36806] = Fluid3D([11054,11344,10577,11273],0); -ELEMENTS[36807] = Fluid3D([11344,10980,10577,10794],0); -ELEMENTS[36808] = Fluid3D([10980,11054,10577,9949],0); -ELEMENTS[36809] = Fluid3D([11054,10577,9949,10562],0); -ELEMENTS[36810] = Fluid3D([10577,9949,10562,9486],0); -ELEMENTS[36811] = Fluid3D([18294,18417,18422,18207],0); -ELEMENTS[36812] = Fluid3D([6573,6525,7187,6420],0); -ELEMENTS[36813] = Fluid3D([6525,7187,6420,7044],0); -ELEMENTS[36814] = Fluid3D([6420,6525,7044,6274],0); -ELEMENTS[36815] = Fluid3D([6420,6525,6274,5935],0); -ELEMENTS[36816] = Fluid3D([6525,7187,7044,7240],0); -ELEMENTS[36817] = Fluid3D([6525,7187,7240,6492],0); -ELEMENTS[36818] = Fluid3D([6525,6274,5935,6238],0); -ELEMENTS[36819] = Fluid3D([7240,6525,6492,7286],0); -ELEMENTS[36820] = Fluid3D([6525,7044,6274,6675],0); -ELEMENTS[36821] = Fluid3D([6274,6525,6675,6238],0); -ELEMENTS[36822] = Fluid3D([6525,7044,6675,7286],0); -ELEMENTS[36823] = Fluid3D([6573,6525,6420,6029],0); -ELEMENTS[36824] = Fluid3D([6525,6420,6029,5935],0); -ELEMENTS[36825] = Fluid3D([7044,6675,7286,7068],0); -ELEMENTS[36826] = Fluid3D([6675,7286,7068,6652],0); -ELEMENTS[36827] = Fluid3D([6675,7286,6652,6525],0); -ELEMENTS[36828] = Fluid3D([7068,6675,6652,6238],0); -ELEMENTS[36829] = Fluid3D([6675,6652,6238,6525],0); -ELEMENTS[36830] = Fluid3D([7068,6675,6238,6065],0); -ELEMENTS[36831] = Fluid3D([7044,6675,7068,6274],0); -ELEMENTS[36832] = Fluid3D([6652,7068,6238,7211],0); -ELEMENTS[36833] = Fluid3D([6238,6652,7211,6187],0); -ELEMENTS[36834] = Fluid3D([6238,6652,6187,5784],0); -ELEMENTS[36835] = Fluid3D([6238,6652,5784,5935],0); -ELEMENTS[36836] = Fluid3D([6238,6652,5935,6525],0); -ELEMENTS[36837] = Fluid3D([16017,15499,15352,15363],0); -ELEMENTS[36838] = Fluid3D([15499,15352,15363,14860],0); -ELEMENTS[36839] = Fluid3D([16017,15499,15363,15502],0); -ELEMENTS[36840] = Fluid3D([15499,15352,14860,14952],0); -ELEMENTS[36841] = Fluid3D([15012,15743,15430,15173],0); -ELEMENTS[36842] = Fluid3D([15430,15012,15173,14627],0); -ELEMENTS[36843] = Fluid3D([12589,13048,12726,11988],0); -ELEMENTS[36844] = Fluid3D([12589,13048,11988,12109],0); -ELEMENTS[36845] = Fluid3D([12589,13048,12109,13303],0); -ELEMENTS[36846] = Fluid3D([11988,12589,12109,11411],0); -ELEMENTS[36847] = Fluid3D([17433,17663,17296,17429],0); -ELEMENTS[36848] = Fluid3D([6006,5577,5785,5378],0); -ELEMENTS[36849] = Fluid3D([15007,15413,14572,15360],0); -ELEMENTS[36850] = Fluid3D([15959,16341,15827,15921],0); -ELEMENTS[36851] = Fluid3D([6909,6599,7035,6110],0); -ELEMENTS[36852] = Fluid3D([15289,15382,15034,14466],0); -ELEMENTS[36853] = Fluid3D([3579,3660,3479,3224],0); -ELEMENTS[36854] = Fluid3D([3579,3660,3224,3544],0); -ELEMENTS[36855] = Fluid3D([3660,3479,3224,3367],0); -ELEMENTS[36856] = Fluid3D([11215,11416,11941,11593],0); -ELEMENTS[36857] = Fluid3D([5817,6216,6536,5606],0); -ELEMENTS[36858] = Fluid3D([10886,11218,11762,10916],0); -ELEMENTS[36859] = Fluid3D([14826,14830,14151,14414],0); -ELEMENTS[36860] = Fluid3D([12068,12105,11327,12187],0); -ELEMENTS[36861] = Fluid3D([8917,9001,8314,9231],0); -ELEMENTS[36862] = Fluid3D([7191,6542,7422,7453],0); -ELEMENTS[36863] = Fluid3D([4074,3816,4053,4330],0); -ELEMENTS[36864] = Fluid3D([15741,15990,15709,15466],0); -ELEMENTS[36865] = Fluid3D([15990,15709,15466,15774],0); -ELEMENTS[36866] = Fluid3D([15741,15990,15466,16244],0); -ELEMENTS[36867] = Fluid3D([6630,7230,7023,6710],0); -ELEMENTS[36868] = Fluid3D([11287,12282,12228,11460],0); -ELEMENTS[36869] = Fluid3D([11287,12282,11460,11234],0); -ELEMENTS[36870] = Fluid3D([11460,11287,11234,10541],0); -ELEMENTS[36871] = Fluid3D([16465,16297,16252,16468],0); -ELEMENTS[36872] = Fluid3D([15897,16337,16317,16140],0); -ELEMENTS[36873] = Fluid3D([4711,4878,4407,4821],0); -ELEMENTS[36874] = Fluid3D([14690,14110,14399,13813],0); -ELEMENTS[36875] = Fluid3D([14110,14399,13813,14146],0); -ELEMENTS[36876] = Fluid3D([14399,13813,14146,13905],0); -ELEMENTS[36877] = Fluid3D([14399,13813,13905,14197],0); -ELEMENTS[36878] = Fluid3D([13813,14146,13905,13182],0); -ELEMENTS[36879] = Fluid3D([13813,14146,13182,13533],0); -ELEMENTS[36880] = Fluid3D([6127,5968,5898,6604],0); -ELEMENTS[36881] = Fluid3D([6127,5968,6604,6421],0); -ELEMENTS[36882] = Fluid3D([5968,6604,6421,6225],0); -ELEMENTS[36883] = Fluid3D([5968,6604,6225,5898],0); -ELEMENTS[36884] = Fluid3D([6225,5968,5898,5350],0); -ELEMENTS[36885] = Fluid3D([4801,5148,4508,4913],0); -ELEMENTS[36886] = Fluid3D([5148,4508,4913,4692],0); -ELEMENTS[36887] = Fluid3D([4913,5148,4692,4998],0); -ELEMENTS[36888] = Fluid3D([4913,5148,4998,5509],0); -ELEMENTS[36889] = Fluid3D([4913,5148,5509,4801],0); -ELEMENTS[36890] = Fluid3D([4508,4801,4913,4858],0); -ELEMENTS[36891] = Fluid3D([4508,4801,4858,4463],0); -ELEMENTS[36892] = Fluid3D([14548,14087,15015,14656],0); -ELEMENTS[36893] = Fluid3D([8671,8178,8981,8189],0); -ELEMENTS[36894] = Fluid3D([13844,13661,14305,13462],0); -ELEMENTS[36895] = Fluid3D([7118,6642,7458,6428],0); -ELEMENTS[36896] = Fluid3D([4432,4282,4768,4584],0); -ELEMENTS[36897] = Fluid3D([9965,10293,9710,9190],0); -ELEMENTS[36898] = Fluid3D([9710,9965,9190,9780],0); -ELEMENTS[36899] = Fluid3D([12520,11786,11835,12506],0); -ELEMENTS[36900] = Fluid3D([5094,4679,5189,4795],0); -ELEMENTS[36901] = Fluid3D([2722,2665,2865,2474],0); -ELEMENTS[36902] = Fluid3D([8247,8222,8721,8844],0); -ELEMENTS[36903] = Fluid3D([8247,8222,8844,8792],0); -ELEMENTS[36904] = Fluid3D([8222,8721,8844,8672],0); -ELEMENTS[36905] = Fluid3D([8844,8222,8672,9169],0); -ELEMENTS[36906] = Fluid3D([8844,8247,8792,9387],0); -ELEMENTS[36907] = Fluid3D([8721,8247,8844,9655],0); -ELEMENTS[36908] = Fluid3D([15714,15765,15604,16124],0); -ELEMENTS[36909] = Fluid3D([15714,15765,16124,16104],0); -ELEMENTS[36910] = Fluid3D([15714,15765,16104,15755],0); -ELEMENTS[36911] = Fluid3D([15765,16104,15755,16265],0); -ELEMENTS[36912] = Fluid3D([15714,15765,15755,15389],0); -ELEMENTS[36913] = Fluid3D([16104,15714,15755,15389],0); -ELEMENTS[36914] = Fluid3D([15765,16124,16104,16553],0); -ELEMENTS[36915] = Fluid3D([16124,15714,16104,16359],0); -ELEMENTS[36916] = Fluid3D([16104,16124,16359,16553],0); -ELEMENTS[36917] = Fluid3D([16359,16104,16553,16181],0); -ELEMENTS[36918] = Fluid3D([16359,16104,16181,15972],0); -ELEMENTS[36919] = Fluid3D([16104,16553,16181,16265],0); -ELEMENTS[36920] = Fluid3D([16359,16104,15972,15714],0); -ELEMENTS[36921] = Fluid3D([15765,15604,16124,16382],0); -ELEMENTS[36922] = Fluid3D([15755,16104,15389,16181],0); -ELEMENTS[36923] = Fluid3D([15755,16104,16181,16265],0); -ELEMENTS[36924] = Fluid3D([16104,16181,15972,15389],0); -ELEMENTS[36925] = Fluid3D([15761,15751,15998,16416],0); -ELEMENTS[36926] = Fluid3D([6895,6120,7190,6768],0); -ELEMENTS[36927] = Fluid3D([3448,3077,3019,3388],0); -ELEMENTS[36928] = Fluid3D([3019,3448,3388,3497],0); -ELEMENTS[36929] = Fluid3D([3448,3388,3497,3913],0); -ELEMENTS[36930] = Fluid3D([3448,3077,3388,3675],0); -ELEMENTS[36931] = Fluid3D([16218,15956,16126,15396],0); -ELEMENTS[36932] = Fluid3D([3332,3358,3828,3632],0); -ELEMENTS[36933] = Fluid3D([17796,17959,17652,17645],0); -ELEMENTS[36934] = Fluid3D([17652,17796,17645,17530],0); -ELEMENTS[36935] = Fluid3D([17796,17959,17645,17947],0); -ELEMENTS[36936] = Fluid3D([17645,17796,17947,17805],0); -ELEMENTS[36937] = Fluid3D([12374,12347,12974,13254],0); -ELEMENTS[36938] = Fluid3D([12374,12347,13254,13114],0); -ELEMENTS[36939] = Fluid3D([12347,12974,13254,13130],0); -ELEMENTS[36940] = Fluid3D([13912,14177,13475,13403],0); -ELEMENTS[36941] = Fluid3D([14370,14479,14763,15142],0); -ELEMENTS[36942] = Fluid3D([17476,17484,17717,17572],0); -ELEMENTS[36943] = Fluid3D([17717,17476,17572,17377],0); -ELEMENTS[36944] = Fluid3D([17250,17129,17357,16981],0); -ELEMENTS[36945] = Fluid3D([17357,17250,16981,17508],0); -ELEMENTS[36946] = Fluid3D([18513,18474,18524,18387],0); -ELEMENTS[36947] = Fluid3D([18513,18474,18387,18480],0); -ELEMENTS[36948] = Fluid3D([18524,18513,18387,18407],0); -ELEMENTS[36949] = Fluid3D([18513,18387,18407,18362],0); -ELEMENTS[36950] = Fluid3D([18513,18387,18362,18480],0); -ELEMENTS[36951] = Fluid3D([18524,18513,18407,18561],0); -ELEMENTS[36952] = Fluid3D([18524,18513,18561,18600],0); -ELEMENTS[36953] = Fluid3D([18513,18474,18480,18567],0); -ELEMENTS[36954] = Fluid3D([18362,18513,18480,18411],0); -ELEMENTS[36955] = Fluid3D([18407,18513,18362,18411],0); -ELEMENTS[36956] = Fluid3D([18387,18407,18362,18208],0); -ELEMENTS[36957] = Fluid3D([18362,18387,18208,18313],0); -ELEMENTS[36958] = Fluid3D([18362,18387,18313,18480],0); -ELEMENTS[36959] = Fluid3D([18387,18208,18313,18114],0); -ELEMENTS[36960] = Fluid3D([18387,18208,18114,18172],0); -ELEMENTS[36961] = Fluid3D([18208,18114,18172,17936],0); -ELEMENTS[36962] = Fluid3D([18208,18114,17936,18101],0); -ELEMENTS[36963] = Fluid3D([18208,18114,18101,18313],0); -ELEMENTS[36964] = Fluid3D([18101,18208,18313,18276],0); -ELEMENTS[36965] = Fluid3D([18313,18101,18276,18067],0); -ELEMENTS[36966] = Fluid3D([18313,18101,18067,18114],0); -ELEMENTS[36967] = Fluid3D([18114,17936,18101,18067],0); -ELEMENTS[36968] = Fluid3D([18172,18208,17936,17958],0); -ELEMENTS[36969] = Fluid3D([18407,18362,18208,18264],0); -ELEMENTS[36970] = Fluid3D([18362,18208,18264,18276],0); -ELEMENTS[36971] = Fluid3D([18264,18362,18276,18363],0); -ELEMENTS[36972] = Fluid3D([18407,18362,18264,18411],0); -ELEMENTS[36973] = Fluid3D([18362,18264,18411,18363],0); -ELEMENTS[36974] = Fluid3D([5016,4651,5176,5079],0); -ELEMENTS[36975] = Fluid3D([18255,18187,18209,18073],0); -ELEMENTS[36976] = Fluid3D([17396,17402,17718,17516],0); -ELEMENTS[36977] = Fluid3D([17402,17718,17516,17472],0); -ELEMENTS[36978] = Fluid3D([17402,17718,17472,17696],0); -ELEMENTS[36979] = Fluid3D([17516,17402,17472,17235],0); -ELEMENTS[36980] = Fluid3D([4775,5302,4883,5094],0); -ELEMENTS[36981] = Fluid3D([9003,8448,8198,8532],0); -ELEMENTS[36982] = Fluid3D([12046,11148,11070,11481],0); -ELEMENTS[36983] = Fluid3D([11070,12046,11481,12220],0); -ELEMENTS[36984] = Fluid3D([12046,11481,12220,12922],0); -ELEMENTS[36985] = Fluid3D([1808,1873,1715,1829],0); -ELEMENTS[36986] = Fluid3D([9276,9084,9355,8405],0); -ELEMENTS[36987] = Fluid3D([14899,14650,15103,14490],0); -ELEMENTS[36988] = Fluid3D([17336,16933,17261,16888],0); -ELEMENTS[36989] = Fluid3D([16602,16781,16260,16718],0); -ELEMENTS[36990] = Fluid3D([6144,5607,5823,5444],0); -ELEMENTS[36991] = Fluid3D([12058,11308,11184,11821],0); -ELEMENTS[36992] = Fluid3D([14063,14366,13565,13578],0); -ELEMENTS[36993] = Fluid3D([10257,9321,9914,9741],0); -ELEMENTS[36994] = Fluid3D([6002,5673,6132,6370],0); -ELEMENTS[36995] = Fluid3D([6179,5806,6339,6039],0); -ELEMENTS[36996] = Fluid3D([17555,17663,17168,17429],0); -ELEMENTS[36997] = Fluid3D([17168,17555,17429,17283],0); -ELEMENTS[36998] = Fluid3D([17168,17555,17283,17515],0); -ELEMENTS[36999] = Fluid3D([12665,12698,13309,12110],0); -ELEMENTS[37000] = Fluid3D([14125,14309,14343,14665],0); -ELEMENTS[37001] = Fluid3D([6995,6660,6458,6446],0); -ELEMENTS[37002] = Fluid3D([6458,6995,6446,7218],0); -ELEMENTS[37003] = Fluid3D([6458,6995,7218,7609],0); -ELEMENTS[37004] = Fluid3D([6458,6995,7609,6969],0); -ELEMENTS[37005] = Fluid3D([17169,16869,17368,17064],0); -ELEMENTS[37006] = Fluid3D([16869,17368,17064,17266],0); -ELEMENTS[37007] = Fluid3D([12584,12594,12156,13363],0); -ELEMENTS[37008] = Fluid3D([11723,11859,12542,11508],0); -ELEMENTS[37009] = Fluid3D([8001,7722,8298,7677],0); -ELEMENTS[37010] = Fluid3D([8001,7722,7677,7195],0); -ELEMENTS[37011] = Fluid3D([8298,8001,7677,8184],0); -ELEMENTS[37012] = Fluid3D([8001,7677,8184,7668],0); -ELEMENTS[37013] = Fluid3D([8001,7677,7668,7195],0); -ELEMENTS[37014] = Fluid3D([7677,8298,8184,7292],0); -ELEMENTS[37015] = Fluid3D([8184,7677,7292,7772],0); -ELEMENTS[37016] = Fluid3D([7677,7668,7195,7772],0); -ELEMENTS[37017] = Fluid3D([15124,14430,15217,15247],0); -ELEMENTS[37018] = Fluid3D([15217,15124,15247,15652],0); -ELEMENTS[37019] = Fluid3D([15647,15064,15261,14934],0); -ELEMENTS[37020] = Fluid3D([10238,9827,9745,8970],0); -ELEMENTS[37021] = Fluid3D([12922,13599,13177,13943],0); -ELEMENTS[37022] = Fluid3D([3677,3941,3617,4086],0); -ELEMENTS[37023] = Fluid3D([3677,3941,4086,4144],0); -ELEMENTS[37024] = Fluid3D([15968,15829,15580,16384],0); -ELEMENTS[37025] = Fluid3D([18267,18005,18112,18079],0); -ELEMENTS[37026] = Fluid3D([18005,18112,18079,17838],0); -ELEMENTS[37027] = Fluid3D([18079,18005,17838,17834],0); -ELEMENTS[37028] = Fluid3D([18005,17838,17834,17676],0); -ELEMENTS[37029] = Fluid3D([18005,17838,17676,17677],0); -ELEMENTS[37030] = Fluid3D([17838,17676,17677,17495],0); -ELEMENTS[37031] = Fluid3D([17677,17838,17495,17714],0); -ELEMENTS[37032] = Fluid3D([17677,17838,17714,18092],0); -ELEMENTS[37033] = Fluid3D([17838,17495,17714,17710],0); -ELEMENTS[37034] = Fluid3D([17495,17677,17714,17473],0); -ELEMENTS[37035] = Fluid3D([17677,17714,17473,17943],0); -ELEMENTS[37036] = Fluid3D([17714,17495,17473,17446],0); -ELEMENTS[37037] = Fluid3D([17473,17714,17446,17830],0); -ELEMENTS[37038] = Fluid3D([17473,17714,17830,17943],0); -ELEMENTS[37039] = Fluid3D([17714,17446,17830,17703],0); -ELEMENTS[37040] = Fluid3D([17838,17676,17495,17834],0); -ELEMENTS[37041] = Fluid3D([18005,18112,17838,17677],0); -ELEMENTS[37042] = Fluid3D([18112,17838,17677,18092],0); -ELEMENTS[37043] = Fluid3D([17834,18005,17676,17751],0); -ELEMENTS[37044] = Fluid3D([17676,17834,17751,17378],0); -ELEMENTS[37045] = Fluid3D([18079,18005,17834,18256],0); -ELEMENTS[37046] = Fluid3D([17838,18079,17834,17710],0); -ELEMENTS[37047] = Fluid3D([18112,18079,17838,18092],0); -ELEMENTS[37048] = Fluid3D([18267,18005,18079,18256],0); -ELEMENTS[37049] = Fluid3D([17830,17714,17703,18037],0); -ELEMENTS[37050] = Fluid3D([18112,18267,18079,18270],0); -ELEMENTS[37051] = Fluid3D([15189,14738,15051,14937],0); -ELEMENTS[37052] = Fluid3D([2993,3023,3403,3128],0); -ELEMENTS[37053] = Fluid3D([9044,8833,9508,8604],0); -ELEMENTS[37054] = Fluid3D([2688,2687,2635,3148],0); -ELEMENTS[37055] = Fluid3D([9165,9684,9393,8912],0); -ELEMENTS[37056] = Fluid3D([12180,11326,11385,11185],0); -ELEMENTS[37057] = Fluid3D([11326,11385,11185,10459],0); -ELEMENTS[37058] = Fluid3D([11385,12180,11185,11773],0); -ELEMENTS[37059] = Fluid3D([11185,11385,11773,10853],0); -ELEMENTS[37060] = Fluid3D([11185,11385,10853,10459],0); -ELEMENTS[37061] = Fluid3D([11385,10853,10459,10424],0); -ELEMENTS[37062] = Fluid3D([11385,11773,10853,11485],0); -ELEMENTS[37063] = Fluid3D([11385,12180,11773,12965],0); -ELEMENTS[37064] = Fluid3D([10853,11385,11485,10907],0); -ELEMENTS[37065] = Fluid3D([11485,10853,10907,10597],0); -ELEMENTS[37066] = Fluid3D([10907,11485,10597,10999],0); -ELEMENTS[37067] = Fluid3D([10597,10907,10999,10302],0); -ELEMENTS[37068] = Fluid3D([10907,11485,10999,11217],0); -ELEMENTS[37069] = Fluid3D([10907,11485,11217,11385],0); -ELEMENTS[37070] = Fluid3D([10999,10907,11217,10302],0); -ELEMENTS[37071] = Fluid3D([10853,10907,10597,10097],0); -ELEMENTS[37072] = Fluid3D([10853,11385,10907,10424],0); -ELEMENTS[37073] = Fluid3D([11326,11385,10459,11236],0); -ELEMENTS[37074] = Fluid3D([15652,15984,16074,15630],0); -ELEMENTS[37075] = Fluid3D([15652,15984,15630,15473],0); -ELEMENTS[37076] = Fluid3D([13094,12893,12194,13204],0); -ELEMENTS[37077] = Fluid3D([4819,5378,5131,4837],0); -ELEMENTS[37078] = Fluid3D([16734,16758,16959,16218],0); -ELEMENTS[37079] = Fluid3D([17670,17433,17236,17168],0); -ELEMENTS[37080] = Fluid3D([5163,4928,5760,5598],0); -ELEMENTS[37081] = Fluid3D([3016,3158,2813,3214],0); -ELEMENTS[37082] = Fluid3D([9142,9016,8188,8750],0); -ELEMENTS[37083] = Fluid3D([15028,14474,14737,14112],0); -ELEMENTS[37084] = Fluid3D([7215,6706,7622,7424],0); -ELEMENTS[37085] = Fluid3D([7215,6706,7424,6742],0); -ELEMENTS[37086] = Fluid3D([7622,7215,7424,8029],0); -ELEMENTS[37087] = Fluid3D([7424,7215,6742,7391],0); -ELEMENTS[37088] = Fluid3D([7424,7215,7391,8318],0); -ELEMENTS[37089] = Fluid3D([7424,7215,8318,8029],0); -ELEMENTS[37090] = Fluid3D([6706,7622,7424,7492],0); -ELEMENTS[37091] = Fluid3D([11552,12239,12633,11755],0); -ELEMENTS[37092] = Fluid3D([11552,12239,11755,11046],0); -ELEMENTS[37093] = Fluid3D([14445,14300,14259,15022],0); -ELEMENTS[37094] = Fluid3D([8265,7678,8370,7427],0); -ELEMENTS[37095] = Fluid3D([7825,7719,8519,8723],0); -ELEMENTS[37096] = Fluid3D([10275,9461,10357,10635],0); -ELEMENTS[37097] = Fluid3D([10357,10275,10635,11445],0); -ELEMENTS[37098] = Fluid3D([12129,12843,12981,12745],0); -ELEMENTS[37099] = Fluid3D([3175,3609,3482,3445],0); -ELEMENTS[37100] = Fluid3D([7227,6861,7610,6935],0); -ELEMENTS[37101] = Fluid3D([7610,7227,6935,7791],0); -ELEMENTS[37102] = Fluid3D([6861,7610,6935,6302],0); -ELEMENTS[37103] = Fluid3D([6416,6193,7023,6234],0); -ELEMENTS[37104] = Fluid3D([16924,17023,17355,17210],0); -ELEMENTS[37105] = Fluid3D([17023,17355,17210,17098],0); -ELEMENTS[37106] = Fluid3D([17023,17355,17098,17367],0); -ELEMENTS[37107] = Fluid3D([17023,17355,17367,16992],0); -ELEMENTS[37108] = Fluid3D([17210,17023,17098,16740],0); -ELEMENTS[37109] = Fluid3D([12703,11973,11696,10882],0); -ELEMENTS[37110] = Fluid3D([7520,8227,8341,7409],0); -ELEMENTS[37111] = Fluid3D([6998,7507,7519,7997],0); -ELEMENTS[37112] = Fluid3D([7519,6998,7997,7745],0); -ELEMENTS[37113] = Fluid3D([12642,12758,12669,13479],0); -ELEMENTS[37114] = Fluid3D([7776,7310,8065,7850],0); -ELEMENTS[37115] = Fluid3D([10490,10122,11502,11010],0); -ELEMENTS[37116] = Fluid3D([10490,10122,11010,10326],0); -ELEMENTS[37117] = Fluid3D([11010,10490,10326,11137],0); -ELEMENTS[37118] = Fluid3D([10326,11010,11137,11133],0); -ELEMENTS[37119] = Fluid3D([11010,10490,11137,11502],0); -ELEMENTS[37120] = Fluid3D([10122,11010,10326,10838],0); -ELEMENTS[37121] = Fluid3D([10122,11010,10838,11502],0); -ELEMENTS[37122] = Fluid3D([11010,10326,10838,10839],0); -ELEMENTS[37123] = Fluid3D([11010,10326,10839,11133],0); -ELEMENTS[37124] = Fluid3D([10326,10839,11133,10110],0); -ELEMENTS[37125] = Fluid3D([10326,10839,10110,10015],0); -ELEMENTS[37126] = Fluid3D([10839,11133,10110,11442],0); -ELEMENTS[37127] = Fluid3D([10838,11010,10839,11482],0); -ELEMENTS[37128] = Fluid3D([11010,10839,11482,11133],0); -ELEMENTS[37129] = Fluid3D([10838,11010,11482,11502],0); -ELEMENTS[37130] = Fluid3D([11010,11482,11502,11137],0); -ELEMENTS[37131] = Fluid3D([11010,11482,11137,11133],0); -ELEMENTS[37132] = Fluid3D([11482,10838,11502,11845],0); -ELEMENTS[37133] = Fluid3D([7864,7395,8363,7504],0); -ELEMENTS[37134] = Fluid3D([14059,13625,14482,14070],0); -ELEMENTS[37135] = Fluid3D([14482,14059,14070,15147],0); -ELEMENTS[37136] = Fluid3D([1854,1876,1756,1789],0); -ELEMENTS[37137] = Fluid3D([1756,1854,1789,1680],0); -ELEMENTS[37138] = Fluid3D([1854,1876,1789,1917],0); -ELEMENTS[37139] = Fluid3D([16019,15516,16274,15835],0); -ELEMENTS[37140] = Fluid3D([16274,16019,15835,16150],0); -ELEMENTS[37141] = Fluid3D([10282,11416,10964,11593],0); -ELEMENTS[37142] = Fluid3D([11416,10964,11593,11215],0); -ELEMENTS[37143] = Fluid3D([6894,6191,6173,6757],0); -ELEMENTS[37144] = Fluid3D([6173,6894,6757,7267],0); -ELEMENTS[37145] = Fluid3D([6894,6757,7267,7627],0); -ELEMENTS[37146] = Fluid3D([6757,7267,7627,7367],0); -ELEMENTS[37147] = Fluid3D([7267,7627,7367,8374],0); -ELEMENTS[37148] = Fluid3D([6757,7267,7367,6601],0); -ELEMENTS[37149] = Fluid3D([7267,7367,6601,7478],0); -ELEMENTS[37150] = Fluid3D([6757,7267,6601,6173],0); -ELEMENTS[37151] = Fluid3D([6601,6757,6173,5852],0); -ELEMENTS[37152] = Fluid3D([6757,6173,5852,6316],0); -ELEMENTS[37153] = Fluid3D([6173,6601,5852,5848],0); -ELEMENTS[37154] = Fluid3D([5703,6043,6204,6556],0); -ELEMENTS[37155] = Fluid3D([6043,6204,6556,6562],0); -ELEMENTS[37156] = Fluid3D([6556,6043,6562,6715],0); -ELEMENTS[37157] = Fluid3D([6556,6043,6715,5936],0); -ELEMENTS[37158] = Fluid3D([14863,15000,15134,14293],0); -ELEMENTS[37159] = Fluid3D([14863,15000,14293,13995],0); -ELEMENTS[37160] = Fluid3D([14265,14747,14510,13825],0); -ELEMENTS[37161] = Fluid3D([9686,9181,8659,9884],0); -ELEMENTS[37162] = Fluid3D([15398,14930,14416,15172],0); -ELEMENTS[37163] = Fluid3D([14930,14416,15172,14641],0); -ELEMENTS[37164] = Fluid3D([15398,14930,15172,15651],0); -ELEMENTS[37165] = Fluid3D([14930,15172,15651,14641],0); -ELEMENTS[37166] = Fluid3D([15172,15398,15651,15626],0); -ELEMENTS[37167] = Fluid3D([14930,14416,14641,14219],0); -ELEMENTS[37168] = Fluid3D([14641,14930,14219,14548],0); -ELEMENTS[37169] = Fluid3D([13287,13093,13190,12234],0); -ELEMENTS[37170] = Fluid3D([9838,10138,10406,10773],0); -ELEMENTS[37171] = Fluid3D([7516,7737,7790,7401],0); -ELEMENTS[37172] = Fluid3D([5226,5351,5855,5517],0); -ELEMENTS[37173] = Fluid3D([15997,15929,15702,16308],0); -ELEMENTS[37174] = Fluid3D([11880,12568,12059,12856],0); -ELEMENTS[37175] = Fluid3D([15323,15420,16003,15605],0); -ELEMENTS[37176] = Fluid3D([16003,15323,15605,15814],0); -ELEMENTS[37177] = Fluid3D([15323,15420,15605,15214],0); -ELEMENTS[37178] = Fluid3D([15605,15323,15214,15166],0); -ELEMENTS[37179] = Fluid3D([15214,15605,15166,15762],0); -ELEMENTS[37180] = Fluid3D([15605,15323,15166,15814],0); -ELEMENTS[37181] = Fluid3D([15605,15166,15762,15814],0); -ELEMENTS[37182] = Fluid3D([11859,11568,12219,12542],0); -ELEMENTS[37183] = Fluid3D([13256,12831,13850,12884],0); -ELEMENTS[37184] = Fluid3D([17704,17635,17554,17317],0); -ELEMENTS[37185] = Fluid3D([18412,18310,18475,18421],0); -ELEMENTS[37186] = Fluid3D([12802,12105,12068,12187],0); -ELEMENTS[37187] = Fluid3D([6518,6945,6069,6208],0); -ELEMENTS[37188] = Fluid3D([6069,6518,6208,5720],0); -ELEMENTS[37189] = Fluid3D([6945,6069,6208,6520],0); -ELEMENTS[37190] = Fluid3D([6208,6069,5720,5724],0); -ELEMENTS[37191] = Fluid3D([6208,6069,5724,5824],0); -ELEMENTS[37192] = Fluid3D([5720,6208,5724,5461],0); -ELEMENTS[37193] = Fluid3D([5724,5720,5461,5280],0); -ELEMENTS[37194] = Fluid3D([5724,5720,5280,6069],0); -ELEMENTS[37195] = Fluid3D([6208,5724,5461,5824],0); -ELEMENTS[37196] = Fluid3D([4070,4378,4624,4450],0); -ELEMENTS[37197] = Fluid3D([16788,16792,16205,16849],0); -ELEMENTS[37198] = Fluid3D([13503,13731,13300,12905],0); -ELEMENTS[37199] = Fluid3D([13731,13300,12905,12667],0); -ELEMENTS[37200] = Fluid3D([12905,13731,12667,13079],0); -ELEMENTS[37201] = Fluid3D([12667,12905,13079,12153],0); -ELEMENTS[37202] = Fluid3D([12905,13731,13079,13503],0); -ELEMENTS[37203] = Fluid3D([12905,13079,12153,13503],0); -ELEMENTS[37204] = Fluid3D([12667,12905,12153,12528],0); -ELEMENTS[37205] = Fluid3D([12905,12153,12528,13503],0); -ELEMENTS[37206] = Fluid3D([12667,12905,12528,13300],0); -ELEMENTS[37207] = Fluid3D([12905,12528,13300,13503],0); -ELEMENTS[37208] = Fluid3D([12963,12948,13057,14074],0); -ELEMENTS[37209] = Fluid3D([17650,17836,17512,17841],0); -ELEMENTS[37210] = Fluid3D([10112,9968,10403,9266],0); -ELEMENTS[37211] = Fluid3D([17199,17329,17592,17420],0); -ELEMENTS[37212] = Fluid3D([4568,4649,5089,4996],0); -ELEMENTS[37213] = Fluid3D([5089,4568,4996,4753],0); -ELEMENTS[37214] = Fluid3D([14158,13734,13850,12884],0); -ELEMENTS[37215] = Fluid3D([11421,11444,12196,12466],0); -ELEMENTS[37216] = Fluid3D([4383,4476,4634,4327],0); -ELEMENTS[37217] = Fluid3D([7472,7829,6953,7353],0); -ELEMENTS[37218] = Fluid3D([7829,6953,7353,7112],0); -ELEMENTS[37219] = Fluid3D([3935,3878,4184,3743],0); -ELEMENTS[37220] = Fluid3D([8282,8358,8450,7960],0); -ELEMENTS[37221] = Fluid3D([6926,7496,7418,7853],0); -ELEMENTS[37222] = Fluid3D([14366,14596,14332,13565],0); -ELEMENTS[37223] = Fluid3D([6298,7010,6638,6797],0); -ELEMENTS[37224] = Fluid3D([5094,5302,5283,4775],0); -ELEMENTS[37225] = Fluid3D([7233,7427,7599,8160],0); -ELEMENTS[37226] = Fluid3D([2776,2494,2442,2662],0); -ELEMENTS[37227] = Fluid3D([3267,3678,3238,3094],0); -ELEMENTS[37228] = Fluid3D([8018,8081,7723,8957],0); -ELEMENTS[37229] = Fluid3D([17737,17535,17920,17746],0); -ELEMENTS[37230] = Fluid3D([4212,3751,4047,4040],0); -ELEMENTS[37231] = Fluid3D([12845,13102,12403,12747],0); -ELEMENTS[37232] = Fluid3D([16584,16793,16509,16407],0); -ELEMENTS[37233] = Fluid3D([13993,14526,14841,14589],0); -ELEMENTS[37234] = Fluid3D([13036,13855,12763,13431],0); -ELEMENTS[37235] = Fluid3D([10016,9372,10343,10502],0); -ELEMENTS[37236] = Fluid3D([10343,10016,10502,11483],0); -ELEMENTS[37237] = Fluid3D([8197,8829,7733,7994],0); -ELEMENTS[37238] = Fluid3D([7733,8197,7994,7641],0); -ELEMENTS[37239] = Fluid3D([4419,4165,4185,3932],0); -ELEMENTS[37240] = Fluid3D([4185,4419,3932,4036],0); -ELEMENTS[37241] = Fluid3D([4419,4165,3932,4060],0); -ELEMENTS[37242] = Fluid3D([15093,15306,15294,15974],0); -ELEMENTS[37243] = Fluid3D([12603,11726,12738,12503],0); -ELEMENTS[37244] = Fluid3D([6167,6330,6541,5748],0); -ELEMENTS[37245] = Fluid3D([7780,7288,6939,6467],0); -ELEMENTS[37246] = Fluid3D([9094,9003,8854,9660],0); -ELEMENTS[37247] = Fluid3D([17206,17157,17438,17758],0); -ELEMENTS[37248] = Fluid3D([17289,16861,16723,16905],0); -ELEMENTS[37249] = Fluid3D([17289,16861,16905,17297],0); -ELEMENTS[37250] = Fluid3D([16723,17289,16905,17304],0); -ELEMENTS[37251] = Fluid3D([16861,16723,16905,16436],0); -ELEMENTS[37252] = Fluid3D([16861,16723,16436,16933],0); -ELEMENTS[37253] = Fluid3D([17289,16905,17304,17434],0); -ELEMENTS[37254] = Fluid3D([17289,16905,17434,17082],0); -ELEMENTS[37255] = Fluid3D([16905,16861,16436,16852],0); -ELEMENTS[37256] = Fluid3D([16905,16861,16852,17297],0); -ELEMENTS[37257] = Fluid3D([16861,16436,16852,16919],0); -ELEMENTS[37258] = Fluid3D([16852,16861,16919,17297],0); -ELEMENTS[37259] = Fluid3D([17304,17289,17434,17560],0); -ELEMENTS[37260] = Fluid3D([13963,14629,14053,13976],0); -ELEMENTS[37261] = Fluid3D([13963,14629,13976,14176],0); -ELEMENTS[37262] = Fluid3D([14629,14053,13976,14310],0); -ELEMENTS[37263] = Fluid3D([1744,1717,1625,1711],0); -ELEMENTS[37264] = Fluid3D([1625,1744,1711,1613],0); -ELEMENTS[37265] = Fluid3D([14099,14800,14551,14303],0); -ELEMENTS[37266] = Fluid3D([14099,14800,14303,14558],0); -ELEMENTS[37267] = Fluid3D([14551,14099,14303,14054],0); -ELEMENTS[37268] = Fluid3D([14303,14099,14558,14056],0); -ELEMENTS[37269] = Fluid3D([9620,9190,9965,9773],0); -ELEMENTS[37270] = Fluid3D([7484,8000,7104,7566],0); -ELEMENTS[37271] = Fluid3D([15129,14799,14855,14315],0); -ELEMENTS[37272] = Fluid3D([5640,5557,5614,6259],0); -ELEMENTS[37273] = Fluid3D([3336,3211,3082,3577],0); -ELEMENTS[37274] = Fluid3D([4160,4666,4483,4427],0); -ELEMENTS[37275] = Fluid3D([9255,9474,9597,10503],0); -ELEMENTS[37276] = Fluid3D([15465,15416,14875,14743],0); -ELEMENTS[37277] = Fluid3D([4011,4035,4449,4318],0); -ELEMENTS[37278] = Fluid3D([11245,11322,10550,10696],0); -ELEMENTS[37279] = Fluid3D([13357,14148,13498,13309],0); -ELEMENTS[37280] = Fluid3D([13654,14249,14008,13442],0); -ELEMENTS[37281] = Fluid3D([17183,16948,17262,17301],0); -ELEMENTS[37282] = Fluid3D([17012,16748,17071,16618],0); -ELEMENTS[37283] = Fluid3D([16748,17071,16618,16799],0); -ELEMENTS[37284] = Fluid3D([17071,17012,16618,16707],0); -ELEMENTS[37285] = Fluid3D([16618,17071,16707,16896],0); -ELEMENTS[37286] = Fluid3D([16618,17071,16896,16799],0); -ELEMENTS[37287] = Fluid3D([17071,16896,16799,17295],0); -ELEMENTS[37288] = Fluid3D([17071,16896,17295,17211],0); -ELEMENTS[37289] = Fluid3D([17071,16896,17211,16707],0); -ELEMENTS[37290] = Fluid3D([17295,17071,17211,17502],0); -ELEMENTS[37291] = Fluid3D([9340,10132,9617,9530],0); -ELEMENTS[37292] = Fluid3D([14936,15427,15584,15512],0); -ELEMENTS[37293] = Fluid3D([18224,18007,17909,18102],0); -ELEMENTS[37294] = Fluid3D([15845,16067,16336,16458],0); -ELEMENTS[37295] = Fluid3D([15845,16067,16458,15846],0); -ELEMENTS[37296] = Fluid3D([18235,17995,18252,18132],0); -ELEMENTS[37297] = Fluid3D([3766,4144,4240,3941],0); -ELEMENTS[37298] = Fluid3D([3699,3333,3687,3646],0); -ELEMENTS[37299] = Fluid3D([12633,12728,11956,12943],0); -ELEMENTS[37300] = Fluid3D([12728,11956,12943,12245],0); -ELEMENTS[37301] = Fluid3D([5194,5084,5218,5793],0); -ELEMENTS[37302] = Fluid3D([13673,13432,13472,12569],0); -ELEMENTS[37303] = Fluid3D([14874,14713,15116,14397],0); -ELEMENTS[37304] = Fluid3D([10729,11292,10384,10631],0); -ELEMENTS[37305] = Fluid3D([10563,10525,10681,11613],0); -ELEMENTS[37306] = Fluid3D([14026,13483,13311,13172],0); -ELEMENTS[37307] = Fluid3D([11109,11306,10235,11257],0); -ELEMENTS[37308] = Fluid3D([4184,4787,4538,4909],0); -ELEMENTS[37309] = Fluid3D([14972,14760,14530,15374],0); -ELEMENTS[37310] = Fluid3D([14179,14250,14073,13023],0); -ELEMENTS[37311] = Fluid3D([7672,7622,7644,8789],0); -ELEMENTS[37312] = Fluid3D([6080,5739,5283,5547],0); -ELEMENTS[37313] = Fluid3D([2056,2096,2074,1928],0); -ELEMENTS[37314] = Fluid3D([12846,12645,13393,13554],0); -ELEMENTS[37315] = Fluid3D([8912,8153,8657,9165],0); -ELEMENTS[37316] = Fluid3D([7840,8499,8031,7585],0); -ELEMENTS[37317] = Fluid3D([11694,10931,10428,11770],0); -ELEMENTS[37318] = Fluid3D([9042,9724,9612,9836],0); -ELEMENTS[37319] = Fluid3D([9612,9042,9836,8729],0); -ELEMENTS[37320] = Fluid3D([3329,3609,3812,3844],0); -ELEMENTS[37321] = Fluid3D([10708,11456,10290,11324],0); -ELEMENTS[37322] = Fluid3D([17599,17683,17310,17628],0); -ELEMENTS[37323] = Fluid3D([16292,15905,15556,15963],0); -ELEMENTS[37324] = Fluid3D([16292,15905,15963,16628],0); -ELEMENTS[37325] = Fluid3D([15905,15556,15963,15347],0); -ELEMENTS[37326] = Fluid3D([15963,15905,15347,16070],0); -ELEMENTS[37327] = Fluid3D([4424,4105,4641,4318],0); -ELEMENTS[37328] = Fluid3D([4424,4105,4318,3863],0); -ELEMENTS[37329] = Fluid3D([13845,13667,13995,14802],0); -ELEMENTS[37330] = Fluid3D([10981,10214,9747,10652],0); -ELEMENTS[37331] = Fluid3D([16381,15916,16097,16499],0); -ELEMENTS[37332] = Fluid3D([6301,5847,6479,6184],0); -ELEMENTS[37333] = Fluid3D([5847,6479,6184,6185],0); -ELEMENTS[37334] = Fluid3D([8260,8355,8641,9505],0); -ELEMENTS[37335] = Fluid3D([11072,11058,10426,10912],0); -ELEMENTS[37336] = Fluid3D([12229,11845,12230,11358],0); -ELEMENTS[37337] = Fluid3D([12230,12229,11358,12103],0); -ELEMENTS[37338] = Fluid3D([12230,12229,12103,13155],0); -ELEMENTS[37339] = Fluid3D([11358,12230,12103,11655],0); -ELEMENTS[37340] = Fluid3D([12229,11845,11358,11492],0); -ELEMENTS[37341] = Fluid3D([12230,12103,11655,12618],0); -ELEMENTS[37342] = Fluid3D([12230,12103,12618,13155],0); -ELEMENTS[37343] = Fluid3D([6158,6120,6203,5632],0); -ELEMENTS[37344] = Fluid3D([16830,16365,16385,16570],0); -ELEMENTS[37345] = Fluid3D([6298,6638,5842,6797],0); -ELEMENTS[37346] = Fluid3D([17109,16964,17185,17243],0); -ELEMENTS[37347] = Fluid3D([17109,16964,17243,16636],0); -ELEMENTS[37348] = Fluid3D([8479,8859,8373,8029],0); -ELEMENTS[37349] = Fluid3D([6178,5656,5809,6583],0); -ELEMENTS[37350] = Fluid3D([5265,5285,4997,5599],0); -ELEMENTS[37351] = Fluid3D([5265,5285,5599,6112],0); -ELEMENTS[37352] = Fluid3D([5285,4997,5599,5243],0); -ELEMENTS[37353] = Fluid3D([15153,14586,14118,14502],0); -ELEMENTS[37354] = Fluid3D([14586,14118,14502,13986],0); -ELEMENTS[37355] = Fluid3D([14118,14502,13986,14068],0); -ELEMENTS[37356] = Fluid3D([14502,13986,14068,14591],0); -ELEMENTS[37357] = Fluid3D([14502,13986,14591,14649],0); -ELEMENTS[37358] = Fluid3D([15136,14733,15205,14741],0); -ELEMENTS[37359] = Fluid3D([15786,15849,16323,16580],0); -ELEMENTS[37360] = Fluid3D([7316,6810,7812,7728],0); -ELEMENTS[37361] = Fluid3D([6196,6230,5684,6412],0); -ELEMENTS[37362] = Fluid3D([6230,5684,6412,5845],0); -ELEMENTS[37363] = Fluid3D([9799,10146,10422,10264],0); -ELEMENTS[37364] = Fluid3D([9753,9762,9012,9905],0); -ELEMENTS[37365] = Fluid3D([9508,9044,9787,8740],0); -ELEMENTS[37366] = Fluid3D([15802,16187,16044,16159],0); -ELEMENTS[37367] = Fluid3D([16772,16675,16778,17181],0); -ELEMENTS[37368] = Fluid3D([9052,8691,9634,8718],0); -ELEMENTS[37369] = Fluid3D([9634,9052,8718,9657],0); -ELEMENTS[37370] = Fluid3D([9052,8691,8718,8157],0); -ELEMENTS[37371] = Fluid3D([8718,9052,8157,8749],0); -ELEMENTS[37372] = Fluid3D([9052,8718,9657,8749],0); -ELEMENTS[37373] = Fluid3D([13019,13008,13623,12643],0); -ELEMENTS[37374] = Fluid3D([11762,10916,11328,10621],0); -ELEMENTS[37375] = Fluid3D([13840,13499,13158,13973],0); -ELEMENTS[37376] = Fluid3D([17951,18090,17905,18217],0); -ELEMENTS[37377] = Fluid3D([12162,11203,11714,11799],0); -ELEMENTS[37378] = Fluid3D([11713,11920,12061,11297],0); -ELEMENTS[37379] = Fluid3D([7586,8427,8362,8035],0); -ELEMENTS[37380] = Fluid3D([8362,7586,8035,8202],0); -ELEMENTS[37381] = Fluid3D([8035,8362,8202,9151],0); -ELEMENTS[37382] = Fluid3D([8362,8202,9151,8496],0); -ELEMENTS[37383] = Fluid3D([9151,8362,8496,9153],0); -ELEMENTS[37384] = Fluid3D([8362,8202,8496,7653],0); -ELEMENTS[37385] = Fluid3D([8362,8202,7653,7586],0); -ELEMENTS[37386] = Fluid3D([8496,8362,7653,8070],0); -ELEMENTS[37387] = Fluid3D([8496,8362,8070,9153],0); -ELEMENTS[37388] = Fluid3D([8362,7653,8070,7586],0); -ELEMENTS[37389] = Fluid3D([7653,8496,8070,7466],0); -ELEMENTS[37390] = Fluid3D([8427,8362,8035,9151],0); -ELEMENTS[37391] = Fluid3D([8202,8496,7653,7967],0); -ELEMENTS[37392] = Fluid3D([8496,7653,7967,7466],0); -ELEMENTS[37393] = Fluid3D([8202,8496,7967,8822],0); -ELEMENTS[37394] = Fluid3D([8496,7967,8822,8314],0); -ELEMENTS[37395] = Fluid3D([7653,8202,7967,7147],0); -ELEMENTS[37396] = Fluid3D([8822,8496,8314,9231],0); -ELEMENTS[37397] = Fluid3D([8822,8496,9231,9602],0); -ELEMENTS[37398] = Fluid3D([8822,8496,9602,9109],0); -ELEMENTS[37399] = Fluid3D([7967,7653,7147,7087],0); -ELEMENTS[37400] = Fluid3D([7967,7653,7087,7466],0); -ELEMENTS[37401] = Fluid3D([7653,7087,7466,6711],0); -ELEMENTS[37402] = Fluid3D([7087,7466,6711,6781],0); -ELEMENTS[37403] = Fluid3D([7087,7466,6781,7866],0); -ELEMENTS[37404] = Fluid3D([6711,7087,6781,6306],0); -ELEMENTS[37405] = Fluid3D([7653,7147,7087,6711],0); -ELEMENTS[37406] = Fluid3D([7466,6711,6781,6842],0); -ELEMENTS[37407] = Fluid3D([8070,7653,7466,7359],0); -ELEMENTS[37408] = Fluid3D([10117,10010,9857,10680],0); -ELEMENTS[37409] = Fluid3D([2987,3374,3116,3032],0); -ELEMENTS[37410] = Fluid3D([3116,2987,3032,2783],0); -ELEMENTS[37411] = Fluid3D([16521,16314,16479,16205],0); -ELEMENTS[37412] = Fluid3D([17930,17980,17793,17966],0); -ELEMENTS[37413] = Fluid3D([18088,18014,17836,17841],0); -ELEMENTS[37414] = Fluid3D([12903,13182,13638,13890],0); -ELEMENTS[37415] = Fluid3D([3356,3103,3012,2853],0); -ELEMENTS[37416] = Fluid3D([10004,10564,10402,11542],0); -ELEMENTS[37417] = Fluid3D([7780,8461,7908,8607],0); -ELEMENTS[37418] = Fluid3D([7908,7780,8607,7648],0); -ELEMENTS[37419] = Fluid3D([10185,9995,10726,10786],0); -ELEMENTS[37420] = Fluid3D([10185,9995,10786,9420],0); -ELEMENTS[37421] = Fluid3D([9995,10726,10786,11506],0); -ELEMENTS[37422] = Fluid3D([10726,10786,11506,11537],0); -ELEMENTS[37423] = Fluid3D([14451,14733,15131,14548],0); -ELEMENTS[37424] = Fluid3D([11178,10833,11520,11924],0); -ELEMENTS[37425] = Fluid3D([11520,11178,11924,12394],0); -ELEMENTS[37426] = Fluid3D([11178,11924,12394,11673],0); -ELEMENTS[37427] = Fluid3D([11924,11520,12394,12062],0); -ELEMENTS[37428] = Fluid3D([11520,11178,12394,11909],0); -ELEMENTS[37429] = Fluid3D([11520,11178,11909,11171],0); -ELEMENTS[37430] = Fluid3D([11178,10833,11924,11958],0); -ELEMENTS[37431] = Fluid3D([15864,15735,16032,16510],0); -ELEMENTS[37432] = Fluid3D([16035,16488,16405,16514],0); -ELEMENTS[37433] = Fluid3D([6152,6305,6038,5522],0); -ELEMENTS[37434] = Fluid3D([12715,12236,12936,13091],0); -ELEMENTS[37435] = Fluid3D([2071,2163,1967,1960],0); -ELEMENTS[37436] = Fluid3D([2163,1967,1960,1942],0); -ELEMENTS[37437] = Fluid3D([2071,2163,1960,2141],0); -ELEMENTS[37438] = Fluid3D([16597,16964,16548,17185],0); -ELEMENTS[37439] = Fluid3D([2722,2474,2481,2665],0); -ELEMENTS[37440] = Fluid3D([7273,6919,6779,7806],0); -ELEMENTS[37441] = Fluid3D([11346,11273,10562,10568],0); -ELEMENTS[37442] = Fluid3D([10562,11346,10568,11039],0); -ELEMENTS[37443] = Fluid3D([11346,10568,11039,10869],0); -ELEMENTS[37444] = Fluid3D([10562,11346,11039,11517],0); -ELEMENTS[37445] = Fluid3D([11346,11039,11517,12160],0); -ELEMENTS[37446] = Fluid3D([10562,11346,11517,11837],0); -ELEMENTS[37447] = Fluid3D([11346,11517,11837,12160],0); -ELEMENTS[37448] = Fluid3D([11346,11273,10568,10869],0); -ELEMENTS[37449] = Fluid3D([11273,10568,10869,10945],0); -ELEMENTS[37450] = Fluid3D([10568,10869,10945,9795],0); -ELEMENTS[37451] = Fluid3D([10568,10562,11039,10013],0); -ELEMENTS[37452] = Fluid3D([11039,10568,10013,10581],0); -ELEMENTS[37453] = Fluid3D([10568,10562,10013,9775],0); -ELEMENTS[37454] = Fluid3D([10013,10568,9775,9807],0); -ELEMENTS[37455] = Fluid3D([10568,9775,9807,9795],0); -ELEMENTS[37456] = Fluid3D([9775,9807,9795,9121],0); -ELEMENTS[37457] = Fluid3D([9807,9795,9121,9890],0); -ELEMENTS[37458] = Fluid3D([9121,9807,9890,9050],0); -ELEMENTS[37459] = Fluid3D([9775,9807,9121,9050],0); -ELEMENTS[37460] = Fluid3D([9807,9795,9890,10869],0); -ELEMENTS[37461] = Fluid3D([9775,10013,9807,9050],0); -ELEMENTS[37462] = Fluid3D([9890,9807,10869,10013],0); -ELEMENTS[37463] = Fluid3D([10013,10568,9807,10869],0); -ELEMENTS[37464] = Fluid3D([10013,10568,10869,10581],0); -ELEMENTS[37465] = Fluid3D([10568,9807,10869,9795],0); -ELEMENTS[37466] = Fluid3D([9807,9890,9050,10013],0); -ELEMENTS[37467] = Fluid3D([9795,9775,9121,8541],0); -ELEMENTS[37468] = Fluid3D([10568,10562,9775,11273],0); -ELEMENTS[37469] = Fluid3D([12880,13210,13244,13947],0); -ELEMENTS[37470] = Fluid3D([15765,15755,15419,16265],0); -ELEMENTS[37471] = Fluid3D([11801,11657,10859,11760],0); -ELEMENTS[37472] = Fluid3D([11657,10859,11760,11009],0); -ELEMENTS[37473] = Fluid3D([2697,2930,2900,3000],0); -ELEMENTS[37474] = Fluid3D([2697,2930,3000,2789],0); -ELEMENTS[37475] = Fluid3D([16782,16633,16506,16880],0); -ELEMENTS[37476] = Fluid3D([16312,15879,16177,16230],0); -ELEMENTS[37477] = Fluid3D([15295,15035,14506,15390],0); -ELEMENTS[37478] = Fluid3D([4217,4003,4014,4519],0); -ELEMENTS[37479] = Fluid3D([5060,5493,5059,4691],0); -ELEMENTS[37480] = Fluid3D([12761,12075,11609,11367],0); -ELEMENTS[37481] = Fluid3D([12075,11609,11367,11082],0); -ELEMENTS[37482] = Fluid3D([11609,11367,11082,10776],0); -ELEMENTS[37483] = Fluid3D([11367,12075,11082,12209],0); -ELEMENTS[37484] = Fluid3D([11609,11367,10776,10896],0); -ELEMENTS[37485] = Fluid3D([12761,12075,11367,11721],0); -ELEMENTS[37486] = Fluid3D([5451,4973,5431,5664],0); -ELEMENTS[37487] = Fluid3D([5431,5451,5664,6039],0); -ELEMENTS[37488] = Fluid3D([7763,7212,6897,7091],0); -ELEMENTS[37489] = Fluid3D([7763,7212,7091,7855],0); -ELEMENTS[37490] = Fluid3D([15163,15459,15424,14933],0); -ELEMENTS[37491] = Fluid3D([8049,8098,8194,8852],0); -ELEMENTS[37492] = Fluid3D([9473,8874,10193,9581],0); -ELEMENTS[37493] = Fluid3D([14214,14836,14361,14806],0); -ELEMENTS[37494] = Fluid3D([2881,3071,3367,2938],0); -ELEMENTS[37495] = Fluid3D([8084,7888,9044,7991],0); -ELEMENTS[37496] = Fluid3D([6958,6661,7354,6901],0); -ELEMENTS[37497] = Fluid3D([3613,3526,3362,3198],0); -ELEMENTS[37498] = Fluid3D([3613,3526,3198,3335],0); -ELEMENTS[37499] = Fluid3D([3198,3613,3335,3437],0); -ELEMENTS[37500] = Fluid3D([12520,12670,12506,13296],0); -ELEMENTS[37501] = Fluid3D([16843,17241,17012,16680],0); -ELEMENTS[37502] = Fluid3D([4564,4923,5303,4894],0); -ELEMENTS[37503] = Fluid3D([4923,5303,4894,5778],0); -ELEMENTS[37504] = Fluid3D([4564,4923,4894,4526],0); -ELEMENTS[37505] = Fluid3D([16058,16397,16326,16161],0); -ELEMENTS[37506] = Fluid3D([6249,7068,6238,6065],0); -ELEMENTS[37507] = Fluid3D([10820,10773,11048,11755],0); -ELEMENTS[37508] = Fluid3D([13882,13516,13606,12908],0); -ELEMENTS[37509] = Fluid3D([5517,5279,4843,4952],0); -ELEMENTS[37510] = Fluid3D([17744,17831,17570,17465],0); -ELEMENTS[37511] = Fluid3D([17831,17570,17465,17567],0); -ELEMENTS[37512] = Fluid3D([17831,17570,17567,17914],0); -ELEMENTS[37513] = Fluid3D([7730,8002,8151,8832],0); -ELEMENTS[37514] = Fluid3D([3479,3145,3250,2938],0); -ELEMENTS[37515] = Fluid3D([3145,3250,2938,2981],0); -ELEMENTS[37516] = Fluid3D([2938,3145,2981,2689],0); -ELEMENTS[37517] = Fluid3D([3145,3250,2981,3548],0); -ELEMENTS[37518] = Fluid3D([15392,15322,14740,15383],0); -ELEMENTS[37519] = Fluid3D([14749,14469,14613,13691],0); -ELEMENTS[37520] = Fluid3D([8763,8514,9668,9334],0); -ELEMENTS[37521] = Fluid3D([5229,5303,4798,4923],0); -ELEMENTS[37522] = Fluid3D([13028,12651,12590,13574],0); -ELEMENTS[37523] = Fluid3D([13141,13767,13297,13046],0); -ELEMENTS[37524] = Fluid3D([13767,13297,13046,14062],0); -ELEMENTS[37525] = Fluid3D([13767,13297,14062,14382],0); -ELEMENTS[37526] = Fluid3D([17395,17037,17176,17152],0); -ELEMENTS[37527] = Fluid3D([17395,17037,17152,17124],0); -ELEMENTS[37528] = Fluid3D([17037,17152,17124,16770],0); -ELEMENTS[37529] = Fluid3D([17037,17152,16770,17176],0); -ELEMENTS[37530] = Fluid3D([17395,17037,17124,16910],0); -ELEMENTS[37531] = Fluid3D([17124,17037,16770,16464],0); -ELEMENTS[37532] = Fluid3D([17037,17124,16910,16464],0); -ELEMENTS[37533] = Fluid3D([17037,16770,16464,16796],0); -ELEMENTS[37534] = Fluid3D([10838,10015,10839,10326],0); -ELEMENTS[37535] = Fluid3D([3654,3874,3764,4203],0); -ELEMENTS[37536] = Fluid3D([7995,7699,7372,7917],0); -ELEMENTS[37537] = Fluid3D([7699,7372,7917,7243],0); -ELEMENTS[37538] = Fluid3D([14243,14771,15176,14683],0); -ELEMENTS[37539] = Fluid3D([4368,4902,4730,4459],0); -ELEMENTS[37540] = Fluid3D([4902,4730,4459,4990],0); -ELEMENTS[37541] = Fluid3D([4902,4730,4990,5423],0); -ELEMENTS[37542] = Fluid3D([4990,4902,5423,4983],0); -ELEMENTS[37543] = Fluid3D([4459,4902,4990,4983],0); -ELEMENTS[37544] = Fluid3D([4368,4902,4459,4983],0); -ELEMENTS[37545] = Fluid3D([4730,4459,4990,4538],0); -ELEMENTS[37546] = Fluid3D([4459,4990,4538,4641],0); -ELEMENTS[37547] = Fluid3D([4730,4459,4538,4088],0); -ELEMENTS[37548] = Fluid3D([4459,4538,4088,3879],0); -ELEMENTS[37549] = Fluid3D([4730,4459,4088,4368],0); -ELEMENTS[37550] = Fluid3D([2944,3154,2855,3040],0); -ELEMENTS[37551] = Fluid3D([17388,17205,17494,17483],0); -ELEMENTS[37552] = Fluid3D([13744,14324,14806,14330],0); -ELEMENTS[37553] = Fluid3D([14230,13564,14020,14252],0); -ELEMENTS[37554] = Fluid3D([4906,4680,5070,4529],0); -ELEMENTS[37555] = Fluid3D([4906,4680,4529,4198],0); -ELEMENTS[37556] = Fluid3D([10074,9429,9279,8582],0); -ELEMENTS[37557] = Fluid3D([11637,12530,11790,12053],0); -ELEMENTS[37558] = Fluid3D([4145,3840,4383,3986],0); -ELEMENTS[37559] = Fluid3D([3364,3214,2985,3038],0); -ELEMENTS[37560] = Fluid3D([3214,2985,3038,2682],0); -ELEMENTS[37561] = Fluid3D([3364,3214,3038,3480],0); -ELEMENTS[37562] = Fluid3D([15208,15260,15314,15741],0); -ELEMENTS[37563] = Fluid3D([15314,15208,15741,15709],0); -ELEMENTS[37564] = Fluid3D([15208,15260,15741,15662],0); -ELEMENTS[37565] = Fluid3D([6139,6814,5959,6143],0); -ELEMENTS[37566] = Fluid3D([13358,14118,13986,14068],0); -ELEMENTS[37567] = Fluid3D([6394,6308,5818,5828],0); -ELEMENTS[37568] = Fluid3D([15234,15060,14965,14214],0); -ELEMENTS[37569] = Fluid3D([3669,3875,4087,4350],0); -ELEMENTS[37570] = Fluid3D([7893,8414,8517,8911],0); -ELEMENTS[37571] = Fluid3D([12133,11819,12195,11280],0); -ELEMENTS[37572] = Fluid3D([7719,7825,7235,7874],0); -ELEMENTS[37573] = Fluid3D([7235,7719,7874,8470],0); -ELEMENTS[37574] = Fluid3D([7719,7874,8470,8723],0); -ELEMENTS[37575] = Fluid3D([7874,8470,8723,7895],0); -ELEMENTS[37576] = Fluid3D([7874,8470,7895,7929],0); -ELEMENTS[37577] = Fluid3D([7719,7825,7874,8723],0); -ELEMENTS[37578] = Fluid3D([14777,15245,14498,15112],0); -ELEMENTS[37579] = Fluid3D([7888,7704,8604,7487],0); -ELEMENTS[37580] = Fluid3D([16351,16023,15872,16260],0); -ELEMENTS[37581] = Fluid3D([15872,16351,16260,16246],0); -ELEMENTS[37582] = Fluid3D([16351,16023,16260,16718],0); -ELEMENTS[37583] = Fluid3D([11230,12051,11918,12055],0); -ELEMENTS[37584] = Fluid3D([12026,11479,12002,12540],0); -ELEMENTS[37585] = Fluid3D([12026,11479,12540,12429],0); -ELEMENTS[37586] = Fluid3D([5591,5745,5744,5171],0); -ELEMENTS[37587] = Fluid3D([9501,10317,10500,10587],0); -ELEMENTS[37588] = Fluid3D([10317,10500,10587,11566],0); -ELEMENTS[37589] = Fluid3D([9501,10317,10587,9619],0); -ELEMENTS[37590] = Fluid3D([14434,14221,14878,13730],0); -ELEMENTS[37591] = Fluid3D([14434,14221,13730,13473],0); -ELEMENTS[37592] = Fluid3D([15526,15144,15634,15563],0); -ELEMENTS[37593] = Fluid3D([13214,12493,12913,11989],0); -ELEMENTS[37594] = Fluid3D([3415,3754,3672,3334],0); -ELEMENTS[37595] = Fluid3D([10970,11321,12141,11616],0); -ELEMENTS[37596] = Fluid3D([12141,10970,11616,11693],0); -ELEMENTS[37597] = Fluid3D([11616,12141,11693,12620],0); -ELEMENTS[37598] = Fluid3D([11616,12141,12620,12623],0); -ELEMENTS[37599] = Fluid3D([11616,12141,12623,12056],0); -ELEMENTS[37600] = Fluid3D([10970,11616,11693,11526],0); -ELEMENTS[37601] = Fluid3D([12620,11616,12623,12286],0); -ELEMENTS[37602] = Fluid3D([11616,11693,11526,12620],0); -ELEMENTS[37603] = Fluid3D([8731,8018,8533,8957],0); -ELEMENTS[37604] = Fluid3D([15340,15458,14848,14961],0); -ELEMENTS[37605] = Fluid3D([14848,15340,14961,14872],0); -ELEMENTS[37606] = Fluid3D([10413,11013,10170,9591],0); -ELEMENTS[37607] = Fluid3D([14051,14232,14431,13529],0); -ELEMENTS[37608] = Fluid3D([4630,4464,5020,4899],0); -ELEMENTS[37609] = Fluid3D([2126,1959,1876,1995],0); -ELEMENTS[37610] = Fluid3D([1959,1876,1995,1849],0); -ELEMENTS[37611] = Fluid3D([1959,1876,1849,1756],0); -ELEMENTS[37612] = Fluid3D([15989,15564,15382,15742],0); -ELEMENTS[37613] = Fluid3D([13815,14186,14481,14831],0); -ELEMENTS[37614] = Fluid3D([14481,13815,14831,14178],0); -ELEMENTS[37615] = Fluid3D([14481,13815,14178,13883],0); -ELEMENTS[37616] = Fluid3D([5075,4772,5511,5218],0); -ELEMENTS[37617] = Fluid3D([7363,7078,6867,7626],0); -ELEMENTS[37618] = Fluid3D([10431,10050,11058,11028],0); -ELEMENTS[37619] = Fluid3D([11539,11224,11092,10297],0); -ELEMENTS[37620] = Fluid3D([9799,10422,9421,10264],0); -ELEMENTS[37621] = Fluid3D([7387,7553,6841,7252],0); -ELEMENTS[37622] = Fluid3D([6841,7387,7252,6839],0); -ELEMENTS[37623] = Fluid3D([7387,7252,6839,7676],0); -ELEMENTS[37624] = Fluid3D([16715,16593,16126,16258],0); -ELEMENTS[37625] = Fluid3D([16126,16715,16258,16469],0); -ELEMENTS[37626] = Fluid3D([16126,16715,16469,16218],0); -ELEMENTS[37627] = Fluid3D([3514,3533,3132,3075],0); -ELEMENTS[37628] = Fluid3D([4952,5351,5226,5517],0); -ELEMENTS[37629] = Fluid3D([6762,7014,6552,7819],0); -ELEMENTS[37630] = Fluid3D([13684,14085,13776,13269],0); -ELEMENTS[37631] = Fluid3D([13118,12877,13295,13051],0); -ELEMENTS[37632] = Fluid3D([13297,12733,12650,11934],0); -ELEMENTS[37633] = Fluid3D([5521,5133,4954,5173],0); -ELEMENTS[37634] = Fluid3D([5179,5699,5331,4746],0); -ELEMENTS[37635] = Fluid3D([17811,17794,17543,17748],0); -ELEMENTS[37636] = Fluid3D([17811,17794,17748,18003],0); -ELEMENTS[37637] = Fluid3D([17811,17794,18003,18100],0); -ELEMENTS[37638] = Fluid3D([17748,17811,18003,17832],0); -ELEMENTS[37639] = Fluid3D([17543,17811,17748,17832],0); -ELEMENTS[37640] = Fluid3D([17794,17748,18003,18097],0); -ELEMENTS[37641] = Fluid3D([18003,17811,18100,18155],0); -ELEMENTS[37642] = Fluid3D([18003,17811,18155,17832],0); -ELEMENTS[37643] = Fluid3D([18100,18003,18155,18097],0); -ELEMENTS[37644] = Fluid3D([17811,17794,18100,17677],0); -ELEMENTS[37645] = Fluid3D([17794,18003,18100,18097],0); -ELEMENTS[37646] = Fluid3D([17794,17543,17748,17493],0); -ELEMENTS[37647] = Fluid3D([17748,17794,17493,17752],0); -ELEMENTS[37648] = Fluid3D([17543,17748,17493,17406],0); -ELEMENTS[37649] = Fluid3D([17748,17493,17406,17752],0); -ELEMENTS[37650] = Fluid3D([17493,17543,17406,17045],0); -ELEMENTS[37651] = Fluid3D([17406,17493,17045,17080],0); -ELEMENTS[37652] = Fluid3D([17493,17406,17752,17532],0); -ELEMENTS[37653] = Fluid3D([17406,17493,17080,17532],0); -ELEMENTS[37654] = Fluid3D([5315,5703,5442,5992],0); -ELEMENTS[37655] = Fluid3D([5315,5703,5992,5764],0); -ELEMENTS[37656] = Fluid3D([5703,5992,5764,6556],0); -ELEMENTS[37657] = Fluid3D([5992,5315,5764,5742],0); -ELEMENTS[37658] = Fluid3D([5764,5992,5742,6005],0); -ELEMENTS[37659] = Fluid3D([5742,5764,6005,5195],0); -ELEMENTS[37660] = Fluid3D([3197,2906,3037,2735],0); -ELEMENTS[37661] = Fluid3D([1966,2081,2143,2135],0); -ELEMENTS[37662] = Fluid3D([4453,4956,4851,4875],0); -ELEMENTS[37663] = Fluid3D([4851,4453,4875,4523],0); -ELEMENTS[37664] = Fluid3D([4453,4875,4523,4520],0); -ELEMENTS[37665] = Fluid3D([4875,4523,4520,4777],0); -ELEMENTS[37666] = Fluid3D([4453,4956,4875,4520],0); -ELEMENTS[37667] = Fluid3D([4875,4523,4777,5238],0); -ELEMENTS[37668] = Fluid3D([15205,15387,15517,16007],0); -ELEMENTS[37669] = Fluid3D([14897,14974,14193,15147],0); -ELEMENTS[37670] = Fluid3D([2403,2401,2349,2130],0); -ELEMENTS[37671] = Fluid3D([2401,2349,2130,2248],0); -ELEMENTS[37672] = Fluid3D([2401,2349,2248,2497],0); -ELEMENTS[37673] = Fluid3D([18474,18606,18599,18639],0); -ELEMENTS[37674] = Fluid3D([2157,2185,1997,2083],0); -ELEMENTS[37675] = Fluid3D([2157,2185,2083,2311],0); -ELEMENTS[37676] = Fluid3D([7700,7068,7044,7286],0); -ELEMENTS[37677] = Fluid3D([14537,14114,14198,13878],0); -ELEMENTS[37678] = Fluid3D([17108,16814,16752,16380],0); -ELEMENTS[37679] = Fluid3D([12209,12719,12327,11721],0); -ELEMENTS[37680] = Fluid3D([12774,11842,12452,12265],0); -ELEMENTS[37681] = Fluid3D([12774,11842,12265,12602],0); -ELEMENTS[37682] = Fluid3D([11842,12452,12265,11939],0); -ELEMENTS[37683] = Fluid3D([11842,12265,12602,11294],0); -ELEMENTS[37684] = Fluid3D([11842,12265,11294,10988],0); -ELEMENTS[37685] = Fluid3D([12265,11842,11939,10988],0); -ELEMENTS[37686] = Fluid3D([4752,4701,4221,4255],0); -ELEMENTS[37687] = Fluid3D([13173,13261,14071,13277],0); -ELEMENTS[37688] = Fluid3D([14135,14353,14207,13419],0); -ELEMENTS[37689] = Fluid3D([12351,13041,12373,12119],0); -ELEMENTS[37690] = Fluid3D([12351,13041,12119,11917],0); -ELEMENTS[37691] = Fluid3D([13215,13734,14158,12884],0); -ELEMENTS[37692] = Fluid3D([4044,4321,4258,3894],0); -ELEMENTS[37693] = Fluid3D([4229,4345,4185,3823],0); -ELEMENTS[37694] = Fluid3D([17320,17664,17534,17441],0); -ELEMENTS[37695] = Fluid3D([17534,17320,17441,17431],0); -ELEMENTS[37696] = Fluid3D([12367,11536,12409,11645],0); -ELEMENTS[37697] = Fluid3D([12367,11536,11645,12212],0); -ELEMENTS[37698] = Fluid3D([5798,5155,5602,5486],0); -ELEMENTS[37699] = Fluid3D([9185,9801,9993,8747],0); -ELEMENTS[37700] = Fluid3D([12673,13157,13652,13308],0); -ELEMENTS[37701] = Fluid3D([13069,12484,12546,13366],0); -ELEMENTS[37702] = Fluid3D([17838,17495,17710,17834],0); -ELEMENTS[37703] = Fluid3D([13046,13345,12647,13141],0); -ELEMENTS[37704] = Fluid3D([5521,5710,6010,5385],0); -ELEMENTS[37705] = Fluid3D([3335,3364,3070,3038],0); -ELEMENTS[37706] = Fluid3D([11235,10216,10990,11239],0); -ELEMENTS[37707] = Fluid3D([12374,11811,12347,13114],0); -ELEMENTS[37708] = Fluid3D([6461,6697,7509,7132],0); -ELEMENTS[37709] = Fluid3D([17999,18223,18132,18107],0); -ELEMENTS[37710] = Fluid3D([4239,4446,4521,3760],0); -ELEMENTS[37711] = Fluid3D([7698,8220,7572,6893],0); -ELEMENTS[37712] = Fluid3D([9263,10170,9963,9591],0); -ELEMENTS[37713] = Fluid3D([17086,16845,16593,17131],0); -ELEMENTS[37714] = Fluid3D([17258,16980,17341,17419],0); -ELEMENTS[37715] = Fluid3D([7719,8519,8081,7585],0); -ELEMENTS[37716] = Fluid3D([8081,7719,7585,7299],0); -ELEMENTS[37717] = Fluid3D([18348,18475,18521,18448],0); -ELEMENTS[37718] = Fluid3D([17557,17645,17770,17896],0); -ELEMENTS[37719] = Fluid3D([2739,2534,2745,2592],0); -ELEMENTS[37720] = Fluid3D([2739,2534,2592,2422],0); -ELEMENTS[37721] = Fluid3D([8671,8178,8189,7456],0); -ELEMENTS[37722] = Fluid3D([18134,18241,18034,18211],0); -ELEMENTS[37723] = Fluid3D([18034,18134,18211,18199],0); -ELEMENTS[37724] = Fluid3D([18034,18134,18199,18106],0); -ELEMENTS[37725] = Fluid3D([18211,18034,18199,18301],0); -ELEMENTS[37726] = Fluid3D([18134,18211,18199,18291],0); -ELEMENTS[37727] = Fluid3D([18199,18211,18301,18365],0); -ELEMENTS[37728] = Fluid3D([18199,18211,18365,18291],0); -ELEMENTS[37729] = Fluid3D([18211,18301,18365,18441],0); -ELEMENTS[37730] = Fluid3D([18211,18365,18291,18134],0); -ELEMENTS[37731] = Fluid3D([18211,18365,18134,18241],0); -ELEMENTS[37732] = Fluid3D([18365,18211,18441,18241],0); -ELEMENTS[37733] = Fluid3D([16975,17351,17346,16932],0); -ELEMENTS[37734] = Fluid3D([11776,11617,11917,12351],0); -ELEMENTS[37735] = Fluid3D([11617,11917,12351,12119],0); -ELEMENTS[37736] = Fluid3D([13533,13890,14386,14146],0); -ELEMENTS[37737] = Fluid3D([13533,13890,14146,13182],0); -ELEMENTS[37738] = Fluid3D([14218,13841,14078,13826],0); -ELEMENTS[37739] = Fluid3D([14218,13841,13826,13137],0); -ELEMENTS[37740] = Fluid3D([15128,14673,15384,14618],0); -ELEMENTS[37741] = Fluid3D([14738,14208,14414,15051],0); -ELEMENTS[37742] = Fluid3D([4083,4532,3888,4320],0); -ELEMENTS[37743] = Fluid3D([5189,5035,4797,4679],0); -ELEMENTS[37744] = Fluid3D([9186,9488,9935,9956],0); -ELEMENTS[37745] = Fluid3D([2876,2833,2779,3062],0); -ELEMENTS[37746] = Fluid3D([6153,6106,5669,5622],0); -ELEMENTS[37747] = Fluid3D([4614,4972,4395,4529],0); -ELEMENTS[37748] = Fluid3D([4395,4614,4529,4045],0); -ELEMENTS[37749] = Fluid3D([4614,4529,4045,4493],0); -ELEMENTS[37750] = Fluid3D([4395,4614,4045,3930],0); -ELEMENTS[37751] = Fluid3D([13997,14454,14714,14916],0); -ELEMENTS[37752] = Fluid3D([12133,11819,11280,10951],0); -ELEMENTS[37753] = Fluid3D([11280,12133,10951,11872],0); -ELEMENTS[37754] = Fluid3D([12133,11819,10951,11638],0); -ELEMENTS[37755] = Fluid3D([11819,10951,11638,10850],0); -ELEMENTS[37756] = Fluid3D([10951,11638,10850,10288],0); -ELEMENTS[37757] = Fluid3D([11638,11819,10850,11212],0); -ELEMENTS[37758] = Fluid3D([6139,6481,5941,6189],0); -ELEMENTS[37759] = Fluid3D([14484,14870,15104,13836],0); -ELEMENTS[37760] = Fluid3D([4164,4623,4528,4711],0); -ELEMENTS[37761] = Fluid3D([9429,9213,8428,9183],0); -ELEMENTS[37762] = Fluid3D([9213,8428,9183,8990],0); -ELEMENTS[37763] = Fluid3D([5776,5633,5526,5224],0); -ELEMENTS[37764] = Fluid3D([5633,5526,5224,4989],0); -ELEMENTS[37765] = Fluid3D([5776,5633,5224,4991],0); -ELEMENTS[37766] = Fluid3D([5633,5224,4991,4758],0); -ELEMENTS[37767] = Fluid3D([5224,4991,4758,4640],0); -ELEMENTS[37768] = Fluid3D([4758,5224,4640,5125],0); -ELEMENTS[37769] = Fluid3D([4758,5224,5125,4989],0); -ELEMENTS[37770] = Fluid3D([5125,4758,4989,4560],0); -ELEMENTS[37771] = Fluid3D([4758,5224,4989,5633],0); -ELEMENTS[37772] = Fluid3D([6971,7057,6308,6394],0); -ELEMENTS[37773] = Fluid3D([7057,6308,6394,6611],0); -ELEMENTS[37774] = Fluid3D([6394,7057,6611,7056],0); -ELEMENTS[37775] = Fluid3D([6394,7057,7056,7064],0); -ELEMENTS[37776] = Fluid3D([6308,6394,6611,5828],0); -ELEMENTS[37777] = Fluid3D([2019,1868,1802,1836],0); -ELEMENTS[37778] = Fluid3D([1868,1802,1836,1705],0); -ELEMENTS[37779] = Fluid3D([2019,1868,1836,1881],0); -ELEMENTS[37780] = Fluid3D([1868,1836,1881,1705],0); -ELEMENTS[37781] = Fluid3D([1836,1881,1705,1823],0); -ELEMENTS[37782] = Fluid3D([1836,1881,1823,1985],0); -ELEMENTS[37783] = Fluid3D([1836,1881,1985,2019],0); -ELEMENTS[37784] = Fluid3D([1881,1823,1985,1917],0); -ELEMENTS[37785] = Fluid3D([1823,1836,1985,1862],0); -ELEMENTS[37786] = Fluid3D([1705,1836,1823,1739],0); -ELEMENTS[37787] = Fluid3D([1836,1823,1739,1862],0); -ELEMENTS[37788] = Fluid3D([1705,1836,1739,1802],0); -ELEMENTS[37789] = Fluid3D([3883,3720,3625,3245],0); -ELEMENTS[37790] = Fluid3D([4449,4863,4673,4414],0); -ELEMENTS[37791] = Fluid3D([4863,4673,4414,5088],0); -ELEMENTS[37792] = Fluid3D([4673,4449,4414,4318],0); -ELEMENTS[37793] = Fluid3D([3613,3786,3362,3927],0); -ELEMENTS[37794] = Fluid3D([3613,3786,3927,4101],0); -ELEMENTS[37795] = Fluid3D([3786,3927,4101,4141],0); -ELEMENTS[37796] = Fluid3D([3786,3927,4141,3776],0); -ELEMENTS[37797] = Fluid3D([10618,10077,10969,10031],0); -ELEMENTS[37798] = Fluid3D([18271,18319,18097,18305],0); -ELEMENTS[37799] = Fluid3D([13025,13119,13806,12888],0); -ELEMENTS[37800] = Fluid3D([13025,13119,12888,12049],0); -ELEMENTS[37801] = Fluid3D([13119,13806,12888,13435],0); -ELEMENTS[37802] = Fluid3D([17335,17362,16880,16991],0); -ELEMENTS[37803] = Fluid3D([15130,14809,15692,15018],0); -ELEMENTS[37804] = Fluid3D([15807,15333,15611,14770],0); -ELEMENTS[37805] = Fluid3D([12219,11930,12695,12863],0); -ELEMENTS[37806] = Fluid3D([12695,12219,12863,13133],0); -ELEMENTS[37807] = Fluid3D([16034,16005,16195,16651],0); -ELEMENTS[37808] = Fluid3D([17431,17859,17813,17884],0); -ELEMENTS[37809] = Fluid3D([15479,15003,15284,15916],0); -ELEMENTS[37810] = Fluid3D([7657,7760,7730,6554],0); -ELEMENTS[37811] = Fluid3D([4030,4242,3777,4175],0); -ELEMENTS[37812] = Fluid3D([4242,3777,4175,4171],0); -ELEMENTS[37813] = Fluid3D([18234,18359,18186,18145],0); -ELEMENTS[37814] = Fluid3D([11135,11820,11790,11978],0); -ELEMENTS[37815] = Fluid3D([18425,18416,18530,18449],0); -ELEMENTS[37816] = Fluid3D([8796,9384,8962,8928],0); -ELEMENTS[37817] = Fluid3D([8796,9384,8928,8752],0); -ELEMENTS[37818] = Fluid3D([8962,8796,8928,8192],0); -ELEMENTS[37819] = Fluid3D([8962,8796,8192,8470],0); -ELEMENTS[37820] = Fluid3D([8796,8928,8192,8752],0); -ELEMENTS[37821] = Fluid3D([3885,3467,3485,3826],0); -ELEMENTS[37822] = Fluid3D([3885,3467,3826,3782],0); -ELEMENTS[37823] = Fluid3D([3467,3826,3782,3699],0); -ELEMENTS[37824] = Fluid3D([2517,2475,2381,2854],0); -ELEMENTS[37825] = Fluid3D([17673,17282,17341,17484],0); -ELEMENTS[37826] = Fluid3D([15958,15598,16118,15915],0); -ELEMENTS[37827] = Fluid3D([9593,9047,8817,9733],0); -ELEMENTS[37828] = Fluid3D([8817,9593,9733,9500],0); -ELEMENTS[37829] = Fluid3D([9593,9047,9733,9983],0); -ELEMENTS[37830] = Fluid3D([12520,12670,13296,13550],0); -ELEMENTS[37831] = Fluid3D([12258,11628,12043,11496],0); -ELEMENTS[37832] = Fluid3D([11628,12043,11496,10862],0); -ELEMENTS[37833] = Fluid3D([11496,11628,10862,10452],0); -ELEMENTS[37834] = Fluid3D([11628,12043,10862,10652],0); -ELEMENTS[37835] = Fluid3D([12258,11628,11496,11479],0); -ELEMENTS[37836] = Fluid3D([11628,11496,11479,10452],0); -ELEMENTS[37837] = Fluid3D([11496,11479,10452,10494],0); -ELEMENTS[37838] = Fluid3D([10862,11628,10652,10981],0); -ELEMENTS[37839] = Fluid3D([10862,11628,10981,10452],0); -ELEMENTS[37840] = Fluid3D([10652,10862,10981,10214],0); -ELEMENTS[37841] = Fluid3D([10862,10981,10214,10452],0); -ELEMENTS[37842] = Fluid3D([17003,17061,16691,16859],0); -ELEMENTS[37843] = Fluid3D([8954,9782,9795,9438],0); -ELEMENTS[37844] = Fluid3D([9795,8954,9438,9002],0); -ELEMENTS[37845] = Fluid3D([16476,16824,16840,16589],0); -ELEMENTS[37846] = Fluid3D([11958,12844,12464,12087],0); -ELEMENTS[37847] = Fluid3D([11958,12844,12087,12612],0); -ELEMENTS[37848] = Fluid3D([12844,12464,12087,12751],0); -ELEMENTS[37849] = Fluid3D([12087,12844,12751,12612],0); -ELEMENTS[37850] = Fluid3D([10754,10946,10452,11479],0); -ELEMENTS[37851] = Fluid3D([10452,10754,11479,11538],0); -ELEMENTS[37852] = Fluid3D([10452,10754,11538,10981],0); -ELEMENTS[37853] = Fluid3D([14787,14170,14132,14266],0); -ELEMENTS[37854] = Fluid3D([14170,14132,14266,13451],0); -ELEMENTS[37855] = Fluid3D([10431,11480,11058,10835],0); -ELEMENTS[37856] = Fluid3D([4368,4410,4719,4440],0); -ELEMENTS[37857] = Fluid3D([15280,14978,15518,14935],0); -ELEMENTS[37858] = Fluid3D([14978,15518,14935,15104],0); -ELEMENTS[37859] = Fluid3D([9495,9835,9103,10307],0); -ELEMENTS[37860] = Fluid3D([13307,12357,13087,13283],0); -ELEMENTS[37861] = Fluid3D([6355,5910,6227,6458],0); -ELEMENTS[37862] = Fluid3D([6227,6355,6458,6969],0); -ELEMENTS[37863] = Fluid3D([8871,9046,9827,9131],0); -ELEMENTS[37864] = Fluid3D([8871,9046,9131,8304],0); -ELEMENTS[37865] = Fluid3D([9827,8871,9131,9400],0); -ELEMENTS[37866] = Fluid3D([17469,17227,17721,17602],0); -ELEMENTS[37867] = Fluid3D([15487,15530,15841,15135],0); -ELEMENTS[37868] = Fluid3D([5650,5642,5146,5439],0); -ELEMENTS[37869] = Fluid3D([5642,5146,5439,5758],0); -ELEMENTS[37870] = Fluid3D([5642,5146,5758,5457],0); -ELEMENTS[37871] = Fluid3D([5642,5146,5457,5998],0); -ELEMENTS[37872] = Fluid3D([5439,5642,5758,5650],0); -ELEMENTS[37873] = Fluid3D([11120,11575,11196,10440],0); -ELEMENTS[37874] = Fluid3D([6987,7753,7854,8042],0); -ELEMENTS[37875] = Fluid3D([11029,10864,11004,12063],0); -ELEMENTS[37876] = Fluid3D([18241,18050,17933,18132],0); -ELEMENTS[37877] = Fluid3D([3332,3828,3535,3632],0); -ELEMENTS[37878] = Fluid3D([16887,16543,16730,16710],0); -ELEMENTS[37879] = Fluid3D([16887,16543,16710,17034],0); -ELEMENTS[37880] = Fluid3D([11095,11057,11570,10372],0); -ELEMENTS[37881] = Fluid3D([16077,15996,15652,15247],0); -ELEMENTS[37882] = Fluid3D([2542,2402,2280,2511],0); -ELEMENTS[37883] = Fluid3D([4474,4334,4883,4775],0); -ELEMENTS[37884] = Fluid3D([4883,4474,4775,4531],0); -ELEMENTS[37885] = Fluid3D([4474,4334,4775,4531],0); -ELEMENTS[37886] = Fluid3D([4883,4474,4531,4679],0); -ELEMENTS[37887] = Fluid3D([12943,12085,12633,12961],0); -ELEMENTS[37888] = Fluid3D([4368,4719,4443,4440],0); -ELEMENTS[37889] = Fluid3D([15953,16035,16405,15585],0); -ELEMENTS[37890] = Fluid3D([5304,5833,5639,5490],0); -ELEMENTS[37891] = Fluid3D([5833,5639,5490,6341],0); -ELEMENTS[37892] = Fluid3D([6566,6616,5997,5956],0); -ELEMENTS[37893] = Fluid3D([7855,7091,7032,7212],0); -ELEMENTS[37894] = Fluid3D([7091,7032,7212,6258],0); -ELEMENTS[37895] = Fluid3D([4328,4792,4375,4170],0); -ELEMENTS[37896] = Fluid3D([17607,17416,17517,17105],0); -ELEMENTS[37897] = Fluid3D([6024,6019,6334,5751],0); -ELEMENTS[37898] = Fluid3D([16132,16200,16381,16453],0); -ELEMENTS[37899] = Fluid3D([2541,2728,2813,2415],0); -ELEMENTS[37900] = Fluid3D([13232,13041,12351,12783],0); -ELEMENTS[37901] = Fluid3D([8970,8378,8784,7791],0); -ELEMENTS[37902] = Fluid3D([14147,14812,14019,14686],0); -ELEMENTS[37903] = Fluid3D([12179,12920,12175,12847],0); -ELEMENTS[37904] = Fluid3D([6675,6274,6238,6065],0); -ELEMENTS[37905] = Fluid3D([15677,16260,16023,15992],0); -ELEMENTS[37906] = Fluid3D([16023,15677,15992,15502],0); -ELEMENTS[37907] = Fluid3D([16342,15821,16176,16486],0); -ELEMENTS[37908] = Fluid3D([17885,17910,18120,17767],0); -ELEMENTS[37909] = Fluid3D([12257,11797,11671,12887],0); -ELEMENTS[37910] = Fluid3D([11769,11796,10711,11097],0); -ELEMENTS[37911] = Fluid3D([11769,11796,11097,11966],0); -ELEMENTS[37912] = Fluid3D([11796,10711,11097,11062],0); -ELEMENTS[37913] = Fluid3D([11097,11796,11062,10926],0); -ELEMENTS[37914] = Fluid3D([11097,11796,10926,11458],0); -ELEMENTS[37915] = Fluid3D([10926,11097,11458,10868],0); -ELEMENTS[37916] = Fluid3D([11097,11458,10868,10558],0); -ELEMENTS[37917] = Fluid3D([11458,10868,10558,11362],0); -ELEMENTS[37918] = Fluid3D([11097,11796,11458,11966],0); -ELEMENTS[37919] = Fluid3D([11062,11097,10926,10263],0); -ELEMENTS[37920] = Fluid3D([11458,10926,10868,10960],0); -ELEMENTS[37921] = Fluid3D([10926,11097,10868,10007],0); -ELEMENTS[37922] = Fluid3D([10868,11097,10558,10263],0); -ELEMENTS[37923] = Fluid3D([10868,11458,10960,11573],0); -ELEMENTS[37924] = Fluid3D([10868,11458,11573,11362],0); -ELEMENTS[37925] = Fluid3D([11573,10868,11362,10482],0); -ELEMENTS[37926] = Fluid3D([11362,11573,10482,11557],0); -ELEMENTS[37927] = Fluid3D([11362,11573,11557,12386],0); -ELEMENTS[37928] = Fluid3D([11362,11573,12386,12202],0); -ELEMENTS[37929] = Fluid3D([11573,10482,11557,10960],0); -ELEMENTS[37930] = Fluid3D([10960,10868,11573,10482],0); -ELEMENTS[37931] = Fluid3D([10926,11097,10007,10263],0); -ELEMENTS[37932] = Fluid3D([11573,11557,12386,12114],0); -ELEMENTS[37933] = Fluid3D([11573,11557,12114,10960],0); -ELEMENTS[37934] = Fluid3D([2219,2237,2204,2021],0); -ELEMENTS[37935] = Fluid3D([2204,2219,2021,2106],0); -ELEMENTS[37936] = Fluid3D([2204,2219,2106,2463],0); -ELEMENTS[37937] = Fluid3D([2219,2021,2106,2043],0); -ELEMENTS[37938] = Fluid3D([14475,13907,14780,14578],0); -ELEMENTS[37939] = Fluid3D([14475,13907,14578,14932],0); -ELEMENTS[37940] = Fluid3D([14578,14475,14932,14780],0); -ELEMENTS[37941] = Fluid3D([14475,13907,14932,14490],0); -ELEMENTS[37942] = Fluid3D([14932,14475,14490,14650],0); -ELEMENTS[37943] = Fluid3D([14475,14932,14780,14650],0); -ELEMENTS[37944] = Fluid3D([16131,16648,16140,16317],0); -ELEMENTS[37945] = Fluid3D([9688,9174,9109,8353],0); -ELEMENTS[37946] = Fluid3D([3973,4293,4403,4016],0); -ELEMENTS[37947] = Fluid3D([11187,12061,11571,11783],0); -ELEMENTS[37948] = Fluid3D([11571,11187,11783,10606],0); -ELEMENTS[37949] = Fluid3D([11187,12061,11783,11950],0); -ELEMENTS[37950] = Fluid3D([11783,11187,11950,11386],0); -ELEMENTS[37951] = Fluid3D([11187,12061,11950,11297],0); -ELEMENTS[37952] = Fluid3D([11950,11187,11297,10629],0); -ELEMENTS[37953] = Fluid3D([5849,5377,4934,5585],0); -ELEMENTS[37954] = Fluid3D([16702,16594,17015,17005],0); -ELEMENTS[37955] = Fluid3D([17015,16702,17005,17327],0); -ELEMENTS[37956] = Fluid3D([13365,12532,12430,13301],0); -ELEMENTS[37957] = Fluid3D([8684,7754,8373,8029],0); -ELEMENTS[37958] = Fluid3D([16692,16275,16812,16454],0); -ELEMENTS[37959] = Fluid3D([16812,16692,16454,17171],0); -ELEMENTS[37960] = Fluid3D([5451,5436,5806,6047],0); -ELEMENTS[37961] = Fluid3D([15271,15699,16042,15299],0); -ELEMENTS[37962] = Fluid3D([2697,2930,2789,2504],0); -ELEMENTS[37963] = Fluid3D([9081,9681,8890,9858],0); -ELEMENTS[37964] = Fluid3D([13985,13167,14039,13478],0); -ELEMENTS[37965] = Fluid3D([9025,8673,8177,8335],0); -ELEMENTS[37966] = Fluid3D([9025,8673,8335,8361],0); -ELEMENTS[37967] = Fluid3D([8177,9025,8335,8145],0); -ELEMENTS[37968] = Fluid3D([8673,8335,8361,8017],0); -ELEMENTS[37969] = Fluid3D([8335,9025,8361,8987],0); -ELEMENTS[37970] = Fluid3D([8335,8361,8017,7357],0); -ELEMENTS[37971] = Fluid3D([16904,17100,16602,17055],0); -ELEMENTS[37972] = Fluid3D([12424,13124,13114,12668],0); -ELEMENTS[37973] = Fluid3D([12424,13124,12668,12835],0); -ELEMENTS[37974] = Fluid3D([11771,12266,11158,11743],0); -ELEMENTS[37975] = Fluid3D([12785,12239,12330,11755],0); -ELEMENTS[37976] = Fluid3D([11118,11570,11823,10372],0); -ELEMENTS[37977] = Fluid3D([10726,9995,10549,11506],0); -ELEMENTS[37978] = Fluid3D([6132,5673,5855,6446],0); -ELEMENTS[37979] = Fluid3D([15929,15415,15702,15116],0); -ELEMENTS[37980] = Fluid3D([8616,7827,8384,8739],0); -ELEMENTS[37981] = Fluid3D([7827,8384,8739,8103],0); -ELEMENTS[37982] = Fluid3D([8384,8616,8739,9036],0); -ELEMENTS[37983] = Fluid3D([8616,7827,8739,7897],0); -ELEMENTS[37984] = Fluid3D([16743,16570,16546,16958],0); -ELEMENTS[37985] = Fluid3D([16546,16743,16958,16866],0); -ELEMENTS[37986] = Fluid3D([4428,4882,4596,4570],0); -ELEMENTS[37987] = Fluid3D([4723,4879,5018,4475],0); -ELEMENTS[37988] = Fluid3D([2647,2970,2849,2800],0); -ELEMENTS[37989] = Fluid3D([16919,17261,17343,17297],0); -ELEMENTS[37990] = Fluid3D([11794,12080,11254,11830],0); -ELEMENTS[37991] = Fluid3D([10785,10179,10983,9819],0); -ELEMENTS[37992] = Fluid3D([14496,14381,14462,15316],0); -ELEMENTS[37993] = Fluid3D([17260,17185,16756,16936],0); -ELEMENTS[37994] = Fluid3D([17960,18045,17693,17948],0); -ELEMENTS[37995] = Fluid3D([13170,13071,12408,13434],0); -ELEMENTS[37996] = Fluid3D([6230,5684,5845,6172],0); -ELEMENTS[37997] = Fluid3D([7934,7668,7225,7728],0); -ELEMENTS[37998] = Fluid3D([2866,2875,2836,2616],0); -ELEMENTS[37999] = Fluid3D([2866,2875,2616,2627],0); -ELEMENTS[38000] = Fluid3D([2875,2616,2627,2697],0); -ELEMENTS[38001] = Fluid3D([2875,2616,2697,2900],0); -ELEMENTS[38002] = Fluid3D([2875,2616,2900,2836],0); -ELEMENTS[38003] = Fluid3D([7096,7310,7776,7850],0); -ELEMENTS[38004] = Fluid3D([9317,9114,10010,9682],0); -ELEMENTS[38005] = Fluid3D([7828,7154,7027,7554],0); -ELEMENTS[38006] = Fluid3D([2354,2194,2416,2338],0); -ELEMENTS[38007] = Fluid3D([2194,2416,2338,2292],0); -ELEMENTS[38008] = Fluid3D([5273,5675,5719,5493],0); -ELEMENTS[38009] = Fluid3D([8144,8995,9122,9026],0); -ELEMENTS[38010] = Fluid3D([15954,16286,16484,16146],0); -ELEMENTS[38011] = Fluid3D([6838,7378,7153,8228],0); -ELEMENTS[38012] = Fluid3D([14996,14880,14882,15362],0); -ELEMENTS[38013] = Fluid3D([14996,14880,15362,15526],0); -ELEMENTS[38014] = Fluid3D([8503,8702,8759,7873],0); -ELEMENTS[38015] = Fluid3D([8503,8702,7873,7829],0); -ELEMENTS[38016] = Fluid3D([8702,8759,7873,7867],0); -ELEMENTS[38017] = Fluid3D([7873,8702,7867,7926],0); -ELEMENTS[38018] = Fluid3D([14083,14896,14907,14643],0); -ELEMENTS[38019] = Fluid3D([14896,14907,14643,15435],0); -ELEMENTS[38020] = Fluid3D([17391,17724,17852,17462],0); -ELEMENTS[38021] = Fluid3D([17391,17724,17462,17570],0); -ELEMENTS[38022] = Fluid3D([17724,17462,17570,17567],0); -ELEMENTS[38023] = Fluid3D([2823,3082,3052,3208],0); -ELEMENTS[38024] = Fluid3D([8398,8683,9098,8246],0); -ELEMENTS[38025] = Fluid3D([8822,9602,9583,9109],0); -ELEMENTS[38026] = Fluid3D([13781,13446,13487,14571],0); -ELEMENTS[38027] = Fluid3D([16492,15998,16617,16126],0); -ELEMENTS[38028] = Fluid3D([7853,7889,8379,7418],0); -ELEMENTS[38029] = Fluid3D([18232,18307,18206,18011],0); -ELEMENTS[38030] = Fluid3D([18198,18029,18179,18123],0); -ELEMENTS[38031] = Fluid3D([18029,18179,18123,17944],0); -ELEMENTS[38032] = Fluid3D([18029,18179,17944,17802],0); -ELEMENTS[38033] = Fluid3D([18123,18029,17944,17786],0); -ELEMENTS[38034] = Fluid3D([18198,18029,18123,17786],0); -ELEMENTS[38035] = Fluid3D([12987,13197,13697,12845],0); -ELEMENTS[38036] = Fluid3D([12972,12729,13204,12019],0); -ELEMENTS[38037] = Fluid3D([12102,12849,11423,11895],0); -ELEMENTS[38038] = Fluid3D([11423,12102,11895,11474],0); -ELEMENTS[38039] = Fluid3D([14667,14801,15184,15574],0); -ELEMENTS[38040] = Fluid3D([14566,14644,14768,14162],0); -ELEMENTS[38041] = Fluid3D([10480,10515,9538,10036],0); -ELEMENTS[38042] = Fluid3D([10480,10515,10036,10718],0); -ELEMENTS[38043] = Fluid3D([9538,10480,10036,9692],0); -ELEMENTS[38044] = Fluid3D([10515,10036,10718,9634],0); -ELEMENTS[38045] = Fluid3D([10036,10718,9634,9645],0); -ELEMENTS[38046] = Fluid3D([10036,10718,9645,10626],0); -ELEMENTS[38047] = Fluid3D([9634,10036,9645,9538],0); -ELEMENTS[38048] = Fluid3D([10036,10718,10626,10922],0); -ELEMENTS[38049] = Fluid3D([16915,16941,16699,16471],0); -ELEMENTS[38050] = Fluid3D([4820,4494,4405,4816],0); -ELEMENTS[38051] = Fluid3D([14955,15540,15504,15148],0); -ELEMENTS[38052] = Fluid3D([14955,15540,15148,14795],0); -ELEMENTS[38053] = Fluid3D([15148,14955,14795,14415],0); -ELEMENTS[38054] = Fluid3D([15504,14955,15148,15123],0); -ELEMENTS[38055] = Fluid3D([6165,6143,5846,6886],0); -ELEMENTS[38056] = Fluid3D([14451,14641,14219,14548],0); -ELEMENTS[38057] = Fluid3D([7411,7032,7855,7661],0); -ELEMENTS[38058] = Fluid3D([17520,17842,17530,17544],0); -ELEMENTS[38059] = Fluid3D([17520,17842,17544,17728],0); -ELEMENTS[38060] = Fluid3D([17842,17544,17728,17569],0); -ELEMENTS[38061] = Fluid3D([17544,17728,17569,17380],0); -ELEMENTS[38062] = Fluid3D([17544,17728,17380,17520],0); -ELEMENTS[38063] = Fluid3D([17380,17544,17520,17225],0); -ELEMENTS[38064] = Fluid3D([17380,17544,17225,17164],0); -ELEMENTS[38065] = Fluid3D([17544,17520,17225,17530],0); -ELEMENTS[38066] = Fluid3D([17569,17544,17380,17164],0); -ELEMENTS[38067] = Fluid3D([17520,17225,17530,17497],0); -ELEMENTS[38068] = Fluid3D([17225,17544,17530,17447],0); -ELEMENTS[38069] = Fluid3D([17225,17380,17164,17095],0); -ELEMENTS[38070] = Fluid3D([17380,17164,17095,17180],0); -ELEMENTS[38071] = Fluid3D([17225,17380,17095,17174],0); -ELEMENTS[38072] = Fluid3D([17530,17520,17497,17764],0); -ELEMENTS[38073] = Fluid3D([17520,17497,17764,17485],0); -ELEMENTS[38074] = Fluid3D([9575,9399,8933,10000],0); -ELEMENTS[38075] = Fluid3D([9575,9399,10000,10526],0); -ELEMENTS[38076] = Fluid3D([11217,10405,10907,10424],0); -ELEMENTS[38077] = Fluid3D([17570,17465,17567,17213],0); -ELEMENTS[38078] = Fluid3D([17570,17465,17213,17340],0); -ELEMENTS[38079] = Fluid3D([17570,17465,17340,17744],0); -ELEMENTS[38080] = Fluid3D([17465,17213,17340,17042],0); -ELEMENTS[38081] = Fluid3D([17213,17570,17340,17026],0); -ELEMENTS[38082] = Fluid3D([17340,17213,17026,17042],0); -ELEMENTS[38083] = Fluid3D([17213,17570,17026,17462],0); -ELEMENTS[38084] = Fluid3D([17570,17340,17026,17322],0); -ELEMENTS[38085] = Fluid3D([17340,17026,17322,16982],0); -ELEMENTS[38086] = Fluid3D([17322,17340,16982,17057],0); -ELEMENTS[38087] = Fluid3D([17340,17026,16982,17042],0); -ELEMENTS[38088] = Fluid3D([16982,17322,17057,16717],0); -ELEMENTS[38089] = Fluid3D([17340,16982,17057,17370],0); -ELEMENTS[38090] = Fluid3D([17057,16982,16717,16613],0); -ELEMENTS[38091] = Fluid3D([17570,17340,17322,17744],0); -ELEMENTS[38092] = Fluid3D([17322,17340,17057,17370],0); -ELEMENTS[38093] = Fluid3D([10028,10016,10993,10087],0); -ELEMENTS[38094] = Fluid3D([10028,10016,10087,9487],0); -ELEMENTS[38095] = Fluid3D([10016,10087,9487,10724],0); -ELEMENTS[38096] = Fluid3D([10028,10016,9487,9104],0); -ELEMENTS[38097] = Fluid3D([10087,10028,9487,9029],0); -ELEMENTS[38098] = Fluid3D([6153,6299,6871,6964],0); -ELEMENTS[38099] = Fluid3D([11696,10882,11545,12703],0); -ELEMENTS[38100] = Fluid3D([15113,15392,15529,15646],0); -ELEMENTS[38101] = Fluid3D([15113,15392,15646,15009],0); -ELEMENTS[38102] = Fluid3D([15392,15529,15646,15937],0); -ELEMENTS[38103] = Fluid3D([10293,11178,11520,11171],0); -ELEMENTS[38104] = Fluid3D([8963,9038,9819,9395],0); -ELEMENTS[38105] = Fluid3D([9038,9819,9395,9230],0); -ELEMENTS[38106] = Fluid3D([8963,9038,9395,8292],0); -ELEMENTS[38107] = Fluid3D([14671,14829,15041,14394],0); -ELEMENTS[38108] = Fluid3D([15041,14671,14394,14294],0); -ELEMENTS[38109] = Fluid3D([15041,14671,14294,14846],0); -ELEMENTS[38110] = Fluid3D([15041,14671,14846,15216],0); -ELEMENTS[38111] = Fluid3D([14671,14294,14846,14192],0); -ELEMENTS[38112] = Fluid3D([14671,14294,14192,13639],0); -ELEMENTS[38113] = Fluid3D([14846,14671,14192,15216],0); -ELEMENTS[38114] = Fluid3D([14294,14846,14192,14967],0); -ELEMENTS[38115] = Fluid3D([14192,14846,15216,14967],0); -ELEMENTS[38116] = Fluid3D([14846,15216,14967,15124],0); -ELEMENTS[38117] = Fluid3D([14967,14846,15124,14294],0); -ELEMENTS[38118] = Fluid3D([14846,15216,15124,15041],0); -ELEMENTS[38119] = Fluid3D([15124,14846,15041,14294],0); -ELEMENTS[38120] = Fluid3D([11295,11160,11770,10422],0); -ELEMENTS[38121] = Fluid3D([12118,11412,11852,12179],0); -ELEMENTS[38122] = Fluid3D([12118,11412,12179,12175],0); -ELEMENTS[38123] = Fluid3D([13482,13798,13818,12704],0); -ELEMENTS[38124] = Fluid3D([5156,5426,5322,5676],0); -ELEMENTS[38125] = Fluid3D([7362,7373,7275,7936],0); -ELEMENTS[38126] = Fluid3D([7373,7275,7936,7051],0); -ELEMENTS[38127] = Fluid3D([16606,16879,17200,17034],0); -ELEMENTS[38128] = Fluid3D([16606,16879,17034,16711],0); -ELEMENTS[38129] = Fluid3D([16606,16879,16711,16526],0); -ELEMENTS[38130] = Fluid3D([15260,15314,15741,15748],0); -ELEMENTS[38131] = Fluid3D([14372,14042,13702,13936],0); -ELEMENTS[38132] = Fluid3D([10546,10346,10767,9702],0); -ELEMENTS[38133] = Fluid3D([13254,12347,13130,13114],0); -ELEMENTS[38134] = Fluid3D([13130,13254,13114,13893],0); -ELEMENTS[38135] = Fluid3D([13254,13114,13893,13889],0); -ELEMENTS[38136] = Fluid3D([13130,13254,13893,13909],0); -ELEMENTS[38137] = Fluid3D([13153,13261,14003,13480],0); -ELEMENTS[38138] = Fluid3D([13261,14003,13480,13672],0); -ELEMENTS[38139] = Fluid3D([13480,13261,13672,12902],0); -ELEMENTS[38140] = Fluid3D([13672,13480,12902,13493],0); -ELEMENTS[38141] = Fluid3D([13480,13261,12902,12641],0); -ELEMENTS[38142] = Fluid3D([12902,13480,12641,13616],0); -ELEMENTS[38143] = Fluid3D([13153,13261,13480,12641],0); -ELEMENTS[38144] = Fluid3D([13261,12902,12641,12113],0); -ELEMENTS[38145] = Fluid3D([12902,12641,12113,11581],0); -ELEMENTS[38146] = Fluid3D([14003,13480,13672,14237],0); -ELEMENTS[38147] = Fluid3D([14003,13480,14237,13153],0); -ELEMENTS[38148] = Fluid3D([13480,13672,14237,14281],0); -ELEMENTS[38149] = Fluid3D([14237,13480,14281,13616],0); -ELEMENTS[38150] = Fluid3D([14281,14237,13616,14404],0); -ELEMENTS[38151] = Fluid3D([14281,14237,14404,15004],0); -ELEMENTS[38152] = Fluid3D([14281,14237,15004,14547],0); -ELEMENTS[38153] = Fluid3D([14281,14237,14547,13672],0); -ELEMENTS[38154] = Fluid3D([14237,14404,15004,15133],0); -ELEMENTS[38155] = Fluid3D([10182,10766,10745,9931],0); -ELEMENTS[38156] = Fluid3D([10182,10766,9931,9017],0); -ELEMENTS[38157] = Fluid3D([10745,10182,9931,9734],0); -ELEMENTS[38158] = Fluid3D([3883,4221,4005,4314],0); -ELEMENTS[38159] = Fluid3D([4221,4005,4314,4752],0); -ELEMENTS[38160] = Fluid3D([18525,18454,18414,18287],0); -ELEMENTS[38161] = Fluid3D([8532,7812,8198,8533],0); -ELEMENTS[38162] = Fluid3D([17148,17435,17253,17456],0); -ELEMENTS[38163] = Fluid3D([14407,14413,13784,14432],0); -ELEMENTS[38164] = Fluid3D([8187,7333,7339,7569],0); -ELEMENTS[38165] = Fluid3D([6526,6113,6718,6341],0); -ELEMENTS[38166] = Fluid3D([6113,6718,6341,6156],0); -ELEMENTS[38167] = Fluid3D([5817,5882,6102,5324],0); -ELEMENTS[38168] = Fluid3D([17149,17382,17072,16948],0); -ELEMENTS[38169] = Fluid3D([3451,3237,3617,3605],0); -ELEMENTS[38170] = Fluid3D([8271,8926,8452,9697],0); -ELEMENTS[38171] = Fluid3D([3008,3035,3189,2703],0); -ELEMENTS[38172] = Fluid3D([14831,14972,14178,14495],0); -ELEMENTS[38173] = Fluid3D([7227,6353,6861,6935],0); -ELEMENTS[38174] = Fluid3D([7227,6353,6935,6912],0); -ELEMENTS[38175] = Fluid3D([6501,7211,6887,6238],0); -ELEMENTS[38176] = Fluid3D([6501,7211,6238,7068],0); -ELEMENTS[38177] = Fluid3D([5797,6418,5942,6201],0); -ELEMENTS[38178] = Fluid3D([17331,17460,17263,17648],0); -ELEMENTS[38179] = Fluid3D([17331,17460,17648,17705],0); -ELEMENTS[38180] = Fluid3D([17460,17263,17648,17542],0); -ELEMENTS[38181] = Fluid3D([5725,6263,6066,6460],0); -ELEMENTS[38182] = Fluid3D([4088,4459,3879,4368],0); -ELEMENTS[38183] = Fluid3D([15517,15387,15131,15473],0); -ELEMENTS[38184] = Fluid3D([2436,2385,2186,2438],0); -ELEMENTS[38185] = Fluid3D([2819,2541,2813,2491],0); -ELEMENTS[38186] = Fluid3D([2541,2813,2491,2415],0); -ELEMENTS[38187] = Fluid3D([2491,2541,2415,2249],0); -ELEMENTS[38188] = Fluid3D([2491,2541,2249,2322],0); -ELEMENTS[38189] = Fluid3D([2541,2415,2249,2386],0); -ELEMENTS[38190] = Fluid3D([2249,2541,2386,2379],0); -ELEMENTS[38191] = Fluid3D([2249,2541,2379,2322],0); -ELEMENTS[38192] = Fluid3D([3668,3647,3480,3335],0); -ELEMENTS[38193] = Fluid3D([11650,12422,11795,12293],0); -ELEMENTS[38194] = Fluid3D([14396,14453,15109,14735],0); -ELEMENTS[38195] = Fluid3D([8466,7525,7701,8143],0); -ELEMENTS[38196] = Fluid3D([18628,18669,18643,18629],0); -ELEMENTS[38197] = Fluid3D([4843,5013,5517,4952],0); -ELEMENTS[38198] = Fluid3D([9109,8584,9126,9583],0); -ELEMENTS[38199] = Fluid3D([15442,15833,15849,15137],0); -ELEMENTS[38200] = Fluid3D([15442,15833,15137,15312],0); -ELEMENTS[38201] = Fluid3D([2235,2448,2477,2357],0); -ELEMENTS[38202] = Fluid3D([2235,2448,2357,2144],0); -ELEMENTS[38203] = Fluid3D([7240,7816,8008,7187],0); -ELEMENTS[38204] = Fluid3D([7240,7816,7187,7044],0); -ELEMENTS[38205] = Fluid3D([8008,7240,7187,7429],0); -ELEMENTS[38206] = Fluid3D([15122,15445,15496,15917],0); -ELEMENTS[38207] = Fluid3D([16015,16080,16319,15543],0); -ELEMENTS[38208] = Fluid3D([4057,4110,4105,4641],0); -ELEMENTS[38209] = Fluid3D([10303,9533,9413,9306],0); -ELEMENTS[38210] = Fluid3D([12505,12588,13414,12648],0); -ELEMENTS[38211] = Fluid3D([7883,7226,7319,6951],0); -ELEMENTS[38212] = Fluid3D([3533,3935,3520,3878],0); -ELEMENTS[38213] = Fluid3D([8721,8991,9417,10109],0); -ELEMENTS[38214] = Fluid3D([5149,4973,4613,4284],0); -ELEMENTS[38215] = Fluid3D([3485,3467,3222,3560],0); -ELEMENTS[38216] = Fluid3D([7586,8427,8035,7451],0); -ELEMENTS[38217] = Fluid3D([11870,11230,11124,11016],0); -ELEMENTS[38218] = Fluid3D([14812,15020,15571,15437],0); -ELEMENTS[38219] = Fluid3D([15020,15571,15437,15856],0); -ELEMENTS[38220] = Fluid3D([14812,15020,15437,15364],0); -ELEMENTS[38221] = Fluid3D([15020,15437,15364,15856],0); -ELEMENTS[38222] = Fluid3D([15437,15364,15856,15510],0); -ELEMENTS[38223] = Fluid3D([15437,15364,15510,15039],0); -ELEMENTS[38224] = Fluid3D([15437,15364,15039,14812],0); -ELEMENTS[38225] = Fluid3D([15510,15437,15039,15571],0); -ELEMENTS[38226] = Fluid3D([15039,15437,14812,15571],0); -ELEMENTS[38227] = Fluid3D([15856,15437,15510,15571],0); -ELEMENTS[38228] = Fluid3D([16861,16436,16919,16888],0); -ELEMENTS[38229] = Fluid3D([16919,16861,16888,17261],0); -ELEMENTS[38230] = Fluid3D([16919,16861,17261,17297],0); -ELEMENTS[38231] = Fluid3D([15270,14536,14767,14662],0); -ELEMENTS[38232] = Fluid3D([8117,8777,8742,7722],0); -ELEMENTS[38233] = Fluid3D([10987,11235,11733,11158],0); -ELEMENTS[38234] = Fluid3D([16954,17078,17215,17354],0); -ELEMENTS[38235] = Fluid3D([13976,14629,14310,14916],0); -ELEMENTS[38236] = Fluid3D([7172,6890,7907,7929],0); -ELEMENTS[38237] = Fluid3D([7907,7172,7929,7723],0); -ELEMENTS[38238] = Fluid3D([6977,6619,7446,6283],0); -ELEMENTS[38239] = Fluid3D([7446,6977,6283,6447],0); -ELEMENTS[38240] = Fluid3D([6977,6619,6283,6044],0); -ELEMENTS[38241] = Fluid3D([4409,4668,4508,4463],0); -ELEMENTS[38242] = Fluid3D([16794,16527,17060,16883],0); -ELEMENTS[38243] = Fluid3D([9546,9263,9963,9102],0); -ELEMENTS[38244] = Fluid3D([16784,17086,16715,16593],0); -ELEMENTS[38245] = Fluid3D([7140,7054,6335,6441],0); -ELEMENTS[38246] = Fluid3D([7054,6335,6441,6164],0); -ELEMENTS[38247] = Fluid3D([2484,2745,2638,2748],0); -ELEMENTS[38248] = Fluid3D([2484,2745,2748,2849],0); -ELEMENTS[38249] = Fluid3D([18146,18175,18341,18075],0); -ELEMENTS[38250] = Fluid3D([18341,18146,18075,18295],0); -ELEMENTS[38251] = Fluid3D([18341,18146,18295,18373],0); -ELEMENTS[38252] = Fluid3D([18295,18341,18373,18467],0); -ELEMENTS[38253] = Fluid3D([18373,18295,18467,18355],0); -ELEMENTS[38254] = Fluid3D([12383,12678,12323,13175],0); -ELEMENTS[38255] = Fluid3D([16235,16328,16146,16642],0); -ELEMENTS[38256] = Fluid3D([7240,6525,7286,7044],0); -ELEMENTS[38257] = Fluid3D([11240,11891,10818,11077],0); -ELEMENTS[38258] = Fluid3D([11240,11891,11077,11207],0); -ELEMENTS[38259] = Fluid3D([18088,18250,18097,18081],0); -ELEMENTS[38260] = Fluid3D([17917,17777,17660,17450],0); -ELEMENTS[38261] = Fluid3D([17127,17459,17368,17181],0); -ELEMENTS[38262] = Fluid3D([14260,15052,14427,14501],0); -ELEMENTS[38263] = Fluid3D([12758,13214,13318,13418],0); -ELEMENTS[38264] = Fluid3D([4944,4878,4713,4407],0); -ELEMENTS[38265] = Fluid3D([4944,4878,4407,4528],0); -ELEMENTS[38266] = Fluid3D([6330,6390,6483,5717],0); -ELEMENTS[38267] = Fluid3D([8458,9068,8566,8552],0); -ELEMENTS[38268] = Fluid3D([8566,8458,8552,7706],0); -ELEMENTS[38269] = Fluid3D([18144,18052,17949,18247],0); -ELEMENTS[38270] = Fluid3D([6442,5916,5604,5795],0); -ELEMENTS[38271] = Fluid3D([5242,4878,4711,4821],0); -ELEMENTS[38272] = Fluid3D([10487,11308,10398,10560],0); -ELEMENTS[38273] = Fluid3D([14760,14470,15291,14724],0); -ELEMENTS[38274] = Fluid3D([14470,15291,14724,15163],0); -ELEMENTS[38275] = Fluid3D([4255,4119,4339,3820],0); -ELEMENTS[38276] = Fluid3D([4119,4339,3820,4375],0); -ELEMENTS[38277] = Fluid3D([2838,2812,3076,3210],0); -ELEMENTS[38278] = Fluid3D([14907,15104,15435,15769],0); -ELEMENTS[38279] = Fluid3D([15864,15735,16510,16217],0); -ELEMENTS[38280] = Fluid3D([10928,10476,9985,9560],0); -ELEMENTS[38281] = Fluid3D([3680,3288,3304,3334],0); -ELEMENTS[38282] = Fluid3D([7236,7116,7918,7182],0); -ELEMENTS[38283] = Fluid3D([12210,12789,12400,12946],0); -ELEMENTS[38284] = Fluid3D([11807,12214,12900,12350],0); -ELEMENTS[38285] = Fluid3D([12214,12900,12350,12956],0); -ELEMENTS[38286] = Fluid3D([12214,12900,12956,12646],0); -ELEMENTS[38287] = Fluid3D([12900,12350,12956,13266],0); -ELEMENTS[38288] = Fluid3D([17438,17739,17758,17415],0); -ELEMENTS[38289] = Fluid3D([13944,14032,14122,14685],0); -ELEMENTS[38290] = Fluid3D([14032,14122,14685,14190],0); -ELEMENTS[38291] = Fluid3D([14032,14122,14190,13798],0); -ELEMENTS[38292] = Fluid3D([17070,17514,17323,17550],0); -ELEMENTS[38293] = Fluid3D([11330,11745,10956,10743],0); -ELEMENTS[38294] = Fluid3D([12196,12065,12699,11306],0); -ELEMENTS[38295] = Fluid3D([14133,13588,14138,13810],0); -ELEMENTS[38296] = Fluid3D([6314,6457,5685,5909],0); -ELEMENTS[38297] = Fluid3D([15884,16188,16174,15509],0); -ELEMENTS[38298] = Fluid3D([16174,15884,15509,15336],0); -ELEMENTS[38299] = Fluid3D([15884,15509,15336,15648],0); -ELEMENTS[38300] = Fluid3D([15003,14498,15245,15112],0); -ELEMENTS[38301] = Fluid3D([11042,11913,11419,11445],0); -ELEMENTS[38302] = Fluid3D([7556,7457,8068,7164],0); -ELEMENTS[38303] = Fluid3D([7457,8068,7164,7181],0); -ELEMENTS[38304] = Fluid3D([7164,7457,7181,6749],0); -ELEMENTS[38305] = Fluid3D([4422,4118,4371,4295],0); -ELEMENTS[38306] = Fluid3D([14119,14337,14278,13770],0); -ELEMENTS[38307] = Fluid3D([10378,9433,9664,9330],0); -ELEMENTS[38308] = Fluid3D([8260,8769,8522,9337],0); -ELEMENTS[38309] = Fluid3D([8260,8769,9337,8641],0); -ELEMENTS[38310] = Fluid3D([9337,8260,8641,9505],0); -ELEMENTS[38311] = Fluid3D([8769,8522,9337,9751],0); -ELEMENTS[38312] = Fluid3D([17741,17873,17415,17737],0); -ELEMENTS[38313] = Fluid3D([17741,17873,17737,17739],0); -ELEMENTS[38314] = Fluid3D([6445,6256,6059,6639],0); -ELEMENTS[38315] = Fluid3D([12635,11796,11769,11966],0); -ELEMENTS[38316] = Fluid3D([2258,2404,2289,2438],0); -ELEMENTS[38317] = Fluid3D([2289,2258,2438,2143],0); -ELEMENTS[38318] = Fluid3D([9984,10096,9467,9153],0); -ELEMENTS[38319] = Fluid3D([10096,9467,9153,9055],0); -ELEMENTS[38320] = Fluid3D([9467,9153,9055,8273],0); -ELEMENTS[38321] = Fluid3D([9467,9984,9153,9151],0); -ELEMENTS[38322] = Fluid3D([4923,4894,4526,5206],0); -ELEMENTS[38323] = Fluid3D([12026,11496,12429,12464],0); -ELEMENTS[38324] = Fluid3D([9447,9019,9813,9966],0); -ELEMENTS[38325] = Fluid3D([9813,9447,9966,10287],0); -ELEMENTS[38326] = Fluid3D([9447,9019,9966,9258],0); -ELEMENTS[38327] = Fluid3D([9966,9447,9258,8631],0); -ELEMENTS[38328] = Fluid3D([9447,9019,9258,8631],0); -ELEMENTS[38329] = Fluid3D([17199,17212,16728,17170],0); -ELEMENTS[38330] = Fluid3D([14952,15486,14832,14877],0); -ELEMENTS[38331] = Fluid3D([15151,15282,15447,15819],0); -ELEMENTS[38332] = Fluid3D([15151,15282,15819,15546],0); -ELEMENTS[38333] = Fluid3D([15282,15447,15819,15812],0); -ELEMENTS[38334] = Fluid3D([15819,15282,15812,15800],0); -ELEMENTS[38335] = Fluid3D([11683,11516,12118,12332],0); -ELEMENTS[38336] = Fluid3D([12118,11683,12332,12450],0); -ELEMENTS[38337] = Fluid3D([9143,9088,9261,10479],0); -ELEMENTS[38338] = Fluid3D([10990,11299,10495,10700],0); -ELEMENTS[38339] = Fluid3D([11871,11936,11516,12332],0); -ELEMENTS[38340] = Fluid3D([11871,11936,12332,12381],0); -ELEMENTS[38341] = Fluid3D([5762,5855,5923,6458],0); -ELEMENTS[38342] = Fluid3D([3840,3575,3845,4145],0); -ELEMENTS[38343] = Fluid3D([3845,3840,4145,4089],0); -ELEMENTS[38344] = Fluid3D([17613,17795,17437,17565],0); -ELEMENTS[38345] = Fluid3D([17613,17795,17565,17868],0); -ELEMENTS[38346] = Fluid3D([9929,10506,11019,10894],0); -ELEMENTS[38347] = Fluid3D([10597,10426,11072,10853],0); -ELEMENTS[38348] = Fluid3D([2865,2722,2474,2783],0); -ELEMENTS[38349] = Fluid3D([9381,9607,9621,8634],0); -ELEMENTS[38350] = Fluid3D([10670,9845,10540,9505],0); -ELEMENTS[38351] = Fluid3D([14761,14082,14298,14621],0); -ELEMENTS[38352] = Fluid3D([17192,17185,17367,17109],0); -ELEMENTS[38353] = Fluid3D([17185,17367,17109,17523],0); -ELEMENTS[38354] = Fluid3D([17109,17185,17523,17243],0); -ELEMENTS[38355] = Fluid3D([10234,9896,9130,9475],0); -ELEMENTS[38356] = Fluid3D([9286,9756,8910,9294],0); -ELEMENTS[38357] = Fluid3D([8910,9286,9294,9062],0); -ELEMENTS[38358] = Fluid3D([5817,6141,6216,5481],0); -ELEMENTS[38359] = Fluid3D([6141,6216,5481,5701],0); -ELEMENTS[38360] = Fluid3D([6216,5481,5701,5706],0); -ELEMENTS[38361] = Fluid3D([5481,5701,5706,5212],0); -ELEMENTS[38362] = Fluid3D([5481,5701,5212,5016],0); -ELEMENTS[38363] = Fluid3D([5706,5481,5212,5332],0); -ELEMENTS[38364] = Fluid3D([5212,5706,5332,5606],0); -ELEMENTS[38365] = Fluid3D([5212,5706,5606,5590],0); -ELEMENTS[38366] = Fluid3D([5212,5706,5590,5701],0); -ELEMENTS[38367] = Fluid3D([5706,5606,5590,6091],0); -ELEMENTS[38368] = Fluid3D([5706,5606,6091,6216],0); -ELEMENTS[38369] = Fluid3D([5701,6216,5706,6213],0); -ELEMENTS[38370] = Fluid3D([5706,5332,5606,5817],0); -ELEMENTS[38371] = Fluid3D([5706,5332,5817,5481],0); -ELEMENTS[38372] = Fluid3D([5332,5817,5481,5324],0); -ELEMENTS[38373] = Fluid3D([5590,5706,6091,6257],0); -ELEMENTS[38374] = Fluid3D([5706,6091,6257,6216],0); -ELEMENTS[38375] = Fluid3D([6091,6257,6216,7117],0); -ELEMENTS[38376] = Fluid3D([6091,5590,6257,5969],0); -ELEMENTS[38377] = Fluid3D([5481,5701,5016,5686],0); -ELEMENTS[38378] = Fluid3D([5481,6141,5701,5686],0); -ELEMENTS[38379] = Fluid3D([5481,5212,5332,5016],0); -ELEMENTS[38380] = Fluid3D([6257,5706,6216,6213],0); -ELEMENTS[38381] = Fluid3D([6216,6257,6213,7117],0); -ELEMENTS[38382] = Fluid3D([6257,6213,7117,6698],0); -ELEMENTS[38383] = Fluid3D([6257,6213,6698,6456],0); -ELEMENTS[38384] = Fluid3D([6257,5706,6213,5590],0); -ELEMENTS[38385] = Fluid3D([6213,6257,5590,5969],0); -ELEMENTS[38386] = Fluid3D([6213,6257,5969,6456],0); -ELEMENTS[38387] = Fluid3D([5701,6216,6213,6538],0); -ELEMENTS[38388] = Fluid3D([5701,6216,6538,6231],0); -ELEMENTS[38389] = Fluid3D([6216,6213,6538,7117],0); -ELEMENTS[38390] = Fluid3D([6216,5481,5706,5817],0); -ELEMENTS[38391] = Fluid3D([6216,6538,6231,6668],0); -ELEMENTS[38392] = Fluid3D([6216,6538,6668,7260],0); -ELEMENTS[38393] = Fluid3D([5481,6141,5686,5730],0); -ELEMENTS[38394] = Fluid3D([6141,5686,5730,5767],0); -ELEMENTS[38395] = Fluid3D([5686,5730,5767,5176],0); -ELEMENTS[38396] = Fluid3D([5767,5686,5176,5629],0); -ELEMENTS[38397] = Fluid3D([5686,5176,5629,5079],0); -ELEMENTS[38398] = Fluid3D([5767,5686,5629,6431],0); -ELEMENTS[38399] = Fluid3D([5481,6141,5730,5817],0); -ELEMENTS[38400] = Fluid3D([5730,5481,5817,5324],0); -ELEMENTS[38401] = Fluid3D([6141,5730,5817,6102],0); -ELEMENTS[38402] = Fluid3D([5730,5817,6102,5324],0); -ELEMENTS[38403] = Fluid3D([6141,5730,6102,5767],0); -ELEMENTS[38404] = Fluid3D([6102,5730,5324,5767],0); -ELEMENTS[38405] = Fluid3D([5730,5324,5767,5176],0); -ELEMENTS[38406] = Fluid3D([5730,5324,5176,5481],0); -ELEMENTS[38407] = Fluid3D([5706,5590,5701,6213],0); -ELEMENTS[38408] = Fluid3D([7030,6624,6483,7310],0); -ELEMENTS[38409] = Fluid3D([7030,6624,7310,7583],0); -ELEMENTS[38410] = Fluid3D([7030,6624,7583,6993],0); -ELEMENTS[38411] = Fluid3D([7310,7030,7583,7850],0); -ELEMENTS[38412] = Fluid3D([7030,7583,7850,7490],0); -ELEMENTS[38413] = Fluid3D([7583,7850,7490,8509],0); -ELEMENTS[38414] = Fluid3D([7030,7583,7490,7076],0); -ELEMENTS[38415] = Fluid3D([6483,7030,7310,7096],0); -ELEMENTS[38416] = Fluid3D([7030,7310,7096,7850],0); -ELEMENTS[38417] = Fluid3D([6624,7310,7583,7337],0); -ELEMENTS[38418] = Fluid3D([7583,6624,7337,6993],0); -ELEMENTS[38419] = Fluid3D([7310,7583,7337,7976],0); -ELEMENTS[38420] = Fluid3D([7583,7337,7976,8079],0); -ELEMENTS[38421] = Fluid3D([7583,7337,8079,6993],0); -ELEMENTS[38422] = Fluid3D([7976,7583,8079,8573],0); -ELEMENTS[38423] = Fluid3D([7310,7583,7976,7850],0); -ELEMENTS[38424] = Fluid3D([7337,7976,8079,8309],0); -ELEMENTS[38425] = Fluid3D([7976,8079,8309,8573],0); -ELEMENTS[38426] = Fluid3D([7583,7976,7850,8573],0); -ELEMENTS[38427] = Fluid3D([7976,7850,8573,8065],0); -ELEMENTS[38428] = Fluid3D([13888,14574,14198,14117],0); -ELEMENTS[38429] = Fluid3D([3492,3244,3542,3117],0); -ELEMENTS[38430] = Fluid3D([9603,10187,9892,9091],0); -ELEMENTS[38431] = Fluid3D([9892,9603,9091,9011],0); -ELEMENTS[38432] = Fluid3D([3934,3451,3617,3605],0); -ELEMENTS[38433] = Fluid3D([3617,3934,3605,4037],0); -ELEMENTS[38434] = Fluid3D([2199,2381,2223,2018],0); -ELEMENTS[38435] = Fluid3D([9748,10005,10469,10200],0); -ELEMENTS[38436] = Fluid3D([12088,12455,12706,12884],0); -ELEMENTS[38437] = Fluid3D([11404,10947,10675,10738],0); -ELEMENTS[38438] = Fluid3D([4248,4407,4528,4944],0); -ELEMENTS[38439] = Fluid3D([7193,7675,6861,7250],0); -ELEMENTS[38440] = Fluid3D([16427,15906,16133,16209],0); -ELEMENTS[38441] = Fluid3D([16683,17080,17113,16889],0); -ELEMENTS[38442] = Fluid3D([16683,17080,16889,16972],0); -ELEMENTS[38443] = Fluid3D([16889,16683,16972,16576],0); -ELEMENTS[38444] = Fluid3D([16972,16889,16576,16836],0); -ELEMENTS[38445] = Fluid3D([6087,6447,5761,5476],0); -ELEMENTS[38446] = Fluid3D([2905,3168,2997,2870],0); -ELEMENTS[38447] = Fluid3D([2905,3168,2870,2943],0); -ELEMENTS[38448] = Fluid3D([2870,2905,2943,2512],0); -ELEMENTS[38449] = Fluid3D([3168,2870,2943,3245],0); -ELEMENTS[38450] = Fluid3D([2870,2943,3245,2924],0); -ELEMENTS[38451] = Fluid3D([2870,2943,2924,2740],0); -ELEMENTS[38452] = Fluid3D([12985,12454,11816,12365],0); -ELEMENTS[38453] = Fluid3D([12454,11816,12365,12501],0); -ELEMENTS[38454] = Fluid3D([11816,12365,12501,11704],0); -ELEMENTS[38455] = Fluid3D([12365,12454,12501,12985],0); -ELEMENTS[38456] = Fluid3D([2677,2419,2735,2703],0); -ELEMENTS[38457] = Fluid3D([14872,14961,15624,15340],0); -ELEMENTS[38458] = Fluid3D([13922,14110,14690,13813],0); -ELEMENTS[38459] = Fluid3D([11246,11225,10569,11366],0); -ELEMENTS[38460] = Fluid3D([18541,18491,18616,18570],0); -ELEMENTS[38461] = Fluid3D([18541,18491,18570,18483],0); -ELEMENTS[38462] = Fluid3D([18541,18491,18483,18334],0); -ELEMENTS[38463] = Fluid3D([8771,9212,8359,9216],0); -ELEMENTS[38464] = Fluid3D([16707,16618,16896,16189],0); -ELEMENTS[38465] = Fluid3D([16707,16618,16189,16360],0); -ELEMENTS[38466] = Fluid3D([16707,16618,16360,17012],0); -ELEMENTS[38467] = Fluid3D([16618,16189,16360,16264],0); -ELEMENTS[38468] = Fluid3D([15527,15848,15453,15002],0); -ELEMENTS[38469] = Fluid3D([16909,16818,16624,17108],0); -ELEMENTS[38470] = Fluid3D([14963,14651,14976,14305],0); -ELEMENTS[38471] = Fluid3D([12654,12550,11876,13035],0); -ELEMENTS[38472] = Fluid3D([14851,15126,14507,15277],0); -ELEMENTS[38473] = Fluid3D([10834,10248,10206,11162],0); -ELEMENTS[38474] = Fluid3D([13470,12793,13279,13022],0); -ELEMENTS[38475] = Fluid3D([13470,12793,13022,12805],0); -ELEMENTS[38476] = Fluid3D([9774,10666,10004,9761],0); -ELEMENTS[38477] = Fluid3D([10597,10303,9533,9992],0); -ELEMENTS[38478] = Fluid3D([9533,10597,9992,10426],0); -ELEMENTS[38479] = Fluid3D([10597,10303,9992,10302],0); -ELEMENTS[38480] = Fluid3D([3943,4377,4488,4186],0); -ELEMENTS[38481] = Fluid3D([4377,4488,4186,5025],0); -ELEMENTS[38482] = Fluid3D([6421,7225,6604,6888],0); -ELEMENTS[38483] = Fluid3D([6421,7225,6888,7588],0); -ELEMENTS[38484] = Fluid3D([7225,6604,6888,7450],0); -ELEMENTS[38485] = Fluid3D([6604,6421,6888,6127],0); -ELEMENTS[38486] = Fluid3D([6888,6604,6127,6405],0); -ELEMENTS[38487] = Fluid3D([6604,6127,6405,5898],0); -ELEMENTS[38488] = Fluid3D([6127,6405,5898,5637],0); -ELEMENTS[38489] = Fluid3D([6127,6405,5637,6188],0); -ELEMENTS[38490] = Fluid3D([2774,3027,2746,3108],0); -ELEMENTS[38491] = Fluid3D([13454,12980,12606,12220],0); -ELEMENTS[38492] = Fluid3D([15824,16206,16295,16193],0); -ELEMENTS[38493] = Fluid3D([15824,16206,16193,15730],0); -ELEMENTS[38494] = Fluid3D([16206,16193,15730,16259],0); -ELEMENTS[38495] = Fluid3D([15824,16206,15730,15774],0); -ELEMENTS[38496] = Fluid3D([16206,16295,16193,16717],0); -ELEMENTS[38497] = Fluid3D([14311,13953,14097,14764],0); -ELEMENTS[38498] = Fluid3D([9685,9499,8783,8820],0); -ELEMENTS[38499] = Fluid3D([3526,3362,3198,2969],0); -ELEMENTS[38500] = Fluid3D([10454,10771,11188,9707],0); -ELEMENTS[38501] = Fluid3D([14365,14356,14711,13622],0); -ELEMENTS[38502] = Fluid3D([12526,11958,12464,11640],0); -ELEMENTS[38503] = Fluid3D([16602,17100,16781,16718],0); -ELEMENTS[38504] = Fluid3D([16120,16308,16502,16406],0); -ELEMENTS[38505] = Fluid3D([13637,13643,12714,13783],0); -ELEMENTS[38506] = Fluid3D([13637,13643,13783,14379],0); -ELEMENTS[38507] = Fluid3D([9417,9135,8645,8441],0); -ELEMENTS[38508] = Fluid3D([2675,2956,2944,2595],0); -ELEMENTS[38509] = Fluid3D([10680,10807,10117,11131],0); -ELEMENTS[38510] = Fluid3D([4742,4659,4204,4570],0); -ELEMENTS[38511] = Fluid3D([17308,16959,17175,16803],0); -ELEMENTS[38512] = Fluid3D([18210,18238,18212,17966],0); -ELEMENTS[38513] = Fluid3D([15398,14930,15651,15403],0); -ELEMENTS[38514] = Fluid3D([14930,15651,15403,14641],0); -ELEMENTS[38515] = Fluid3D([16900,17227,17469,17221],0); -ELEMENTS[38516] = Fluid3D([17227,17469,17221,17602],0); -ELEMENTS[38517] = Fluid3D([16900,17227,17221,16729],0); -ELEMENTS[38518] = Fluid3D([11238,12273,11104,11284],0); -ELEMENTS[38519] = Fluid3D([9120,9766,10221,9629],0); -ELEMENTS[38520] = Fluid3D([9120,9766,9629,9959],0); -ELEMENTS[38521] = Fluid3D([9629,9120,9959,9061],0); -ELEMENTS[38522] = Fluid3D([9629,9120,9061,8620],0); -ELEMENTS[38523] = Fluid3D([9629,9120,8620,8945],0); -ELEMENTS[38524] = Fluid3D([8620,9629,8945,8820],0); -ELEMENTS[38525] = Fluid3D([9120,9061,8620,8132],0); -ELEMENTS[38526] = Fluid3D([9061,8620,8132,8820],0); -ELEMENTS[38527] = Fluid3D([8945,8620,8820,7629],0); -ELEMENTS[38528] = Fluid3D([9120,8620,8945,8283],0); -ELEMENTS[38529] = Fluid3D([8620,8945,8283,7629],0); -ELEMENTS[38530] = Fluid3D([9120,8620,8283,8132],0); -ELEMENTS[38531] = Fluid3D([17643,17560,17297,17261],0); -ELEMENTS[38532] = Fluid3D([16011,15735,15687,16219],0); -ELEMENTS[38533] = Fluid3D([15967,15377,15773,15365],0); -ELEMENTS[38534] = Fluid3D([15377,15773,15365,15356],0); -ELEMENTS[38535] = Fluid3D([6337,6923,6810,7316],0); -ELEMENTS[38536] = Fluid3D([12401,11886,12463,11369],0); -ELEMENTS[38537] = Fluid3D([3535,3242,3632,3523],0); -ELEMENTS[38538] = Fluid3D([16620,16510,16032,15735],0); -ELEMENTS[38539] = Fluid3D([5229,5329,5454,4834],0); -ELEMENTS[38540] = Fluid3D([18162,18035,18105,17968],0); -ELEMENTS[38541] = Fluid3D([17250,16804,16981,16917],0); -ELEMENTS[38542] = Fluid3D([4546,4106,4112,4742],0); -ELEMENTS[38543] = Fluid3D([5350,5756,5898,6225],0); -ELEMENTS[38544] = Fluid3D([7278,6616,6670,7141],0); -ELEMENTS[38545] = Fluid3D([6616,6670,7141,6281],0); -ELEMENTS[38546] = Fluid3D([6670,7141,6281,7221],0); -ELEMENTS[38547] = Fluid3D([6926,7418,7185,7889],0); -ELEMENTS[38548] = Fluid3D([8633,8369,8917,9338],0); -ELEMENTS[38549] = Fluid3D([15094,15555,15609,15547],0); -ELEMENTS[38550] = Fluid3D([15094,15555,15547,15376],0); -ELEMENTS[38551] = Fluid3D([15094,15555,15376,15182],0); -ELEMENTS[38552] = Fluid3D([15555,15547,15376,16028],0); -ELEMENTS[38553] = Fluid3D([15547,15094,15376,14834],0); -ELEMENTS[38554] = Fluid3D([15547,15376,16028,15623],0); -ELEMENTS[38555] = Fluid3D([16028,15547,15623,15750],0); -ELEMENTS[38556] = Fluid3D([15547,15623,15750,15330],0); -ELEMENTS[38557] = Fluid3D([16028,15547,15750,15609],0); -ELEMENTS[38558] = Fluid3D([15547,15750,15609,15052],0); -ELEMENTS[38559] = Fluid3D([15376,15555,16028,16296],0); -ELEMENTS[38560] = Fluid3D([15547,15376,15623,14834],0); -ELEMENTS[38561] = Fluid3D([15555,15547,16028,15609],0); -ELEMENTS[38562] = Fluid3D([15094,15376,14834,14439],0); -ELEMENTS[38563] = Fluid3D([15547,15094,14834,15052],0); -ELEMENTS[38564] = Fluid3D([15623,15547,14834,15330],0); -ELEMENTS[38565] = Fluid3D([14387,14789,15005,15179],0); -ELEMENTS[38566] = Fluid3D([14789,15005,15179,15482],0); -ELEMENTS[38567] = Fluid3D([14789,15005,15482,15309],0); -ELEMENTS[38568] = Fluid3D([14789,15005,15309,14570],0); -ELEMENTS[38569] = Fluid3D([14789,15005,14570,14045],0); -ELEMENTS[38570] = Fluid3D([15005,15309,14570,14684],0); -ELEMENTS[38571] = Fluid3D([14570,15005,14684,14165],0); -ELEMENTS[38572] = Fluid3D([15309,14789,14570,14767],0); -ELEMENTS[38573] = Fluid3D([18372,18419,18482,18279],0); -ELEMENTS[38574] = Fluid3D([4318,4721,4424,4267],0); -ELEMENTS[38575] = Fluid3D([4537,4527,4086,4566],0); -ELEMENTS[38576] = Fluid3D([7764,7907,8533,7340],0); -ELEMENTS[38577] = Fluid3D([14371,14983,14296,14665],0); -ELEMENTS[38578] = Fluid3D([8398,7698,7572,7615],0); -ELEMENTS[38579] = Fluid3D([8398,7698,7615,8417],0); -ELEMENTS[38580] = Fluid3D([7698,7615,8417,7866],0); -ELEMENTS[38581] = Fluid3D([6431,6505,6245,7222],0); -ELEMENTS[38582] = Fluid3D([14125,14309,14665,14814],0); -ELEMENTS[38583] = Fluid3D([14665,14125,14814,14350],0); -ELEMENTS[38584] = Fluid3D([5771,6166,5640,6259],0); -ELEMENTS[38585] = Fluid3D([11962,11086,11860,11612],0); -ELEMENTS[38586] = Fluid3D([13045,13527,13336,13141],0); -ELEMENTS[38587] = Fluid3D([13336,13045,13141,12459],0); -ELEMENTS[38588] = Fluid3D([13045,13527,13141,12378],0); -ELEMENTS[38589] = Fluid3D([17488,17772,17770,17871],0); -ELEMENTS[38590] = Fluid3D([17429,17593,17283,17555],0); -ELEMENTS[38591] = Fluid3D([17593,17283,17555,17441],0); -ELEMENTS[38592] = Fluid3D([17578,17851,17749,17848],0); -ELEMENTS[38593] = Fluid3D([17749,17578,17848,17338],0); -ELEMENTS[38594] = Fluid3D([8080,8767,8651,7974],0); -ELEMENTS[38595] = Fluid3D([8651,8080,7974,7537],0); -ELEMENTS[38596] = Fluid3D([8080,7974,7537,7678],0); -ELEMENTS[38597] = Fluid3D([8080,7974,7678,8386],0); -ELEMENTS[38598] = Fluid3D([8080,7974,8386,8767],0); -ELEMENTS[38599] = Fluid3D([7537,8080,7678,8370],0); -ELEMENTS[38600] = Fluid3D([7678,8080,8386,8767],0); -ELEMENTS[38601] = Fluid3D([17021,17003,16691,16649],0); -ELEMENTS[38602] = Fluid3D([16691,17021,16649,16422],0); -ELEMENTS[38603] = Fluid3D([17790,17706,18035,17882],0); -ELEMENTS[38604] = Fluid3D([18035,17790,17882,17968],0); -ELEMENTS[38605] = Fluid3D([17790,17706,17882,17399],0); -ELEMENTS[38606] = Fluid3D([16975,16941,16951,16656],0); -ELEMENTS[38607] = Fluid3D([12533,12216,11843,11423],0); -ELEMENTS[38608] = Fluid3D([17050,17202,17016,16700],0); -ELEMENTS[38609] = Fluid3D([4234,4509,4007,4081],0); -ELEMENTS[38610] = Fluid3D([4007,4234,4081,3570],0); -ELEMENTS[38611] = Fluid3D([4509,4007,4081,4083],0); -ELEMENTS[38612] = Fluid3D([4509,4007,4083,4493],0); -ELEMENTS[38613] = Fluid3D([4007,4081,4083,3476],0); -ELEMENTS[38614] = Fluid3D([10921,11534,11044,10116],0); -ELEMENTS[38615] = Fluid3D([6273,5932,5543,5562],0); -ELEMENTS[38616] = Fluid3D([3212,3244,2976,2911],0); -ELEMENTS[38617] = Fluid3D([3212,3244,2911,3117],0); -ELEMENTS[38618] = Fluid3D([3396,2998,3290,3232],0); -ELEMENTS[38619] = Fluid3D([3290,3396,3232,3681],0); -ELEMENTS[38620] = Fluid3D([3290,3396,3681,3565],0); -ELEMENTS[38621] = Fluid3D([3396,3232,3681,3441],0); -ELEMENTS[38622] = Fluid3D([3396,3232,3441,2998],0); -ELEMENTS[38623] = Fluid3D([3681,3396,3441,3667],0); -ELEMENTS[38624] = Fluid3D([3396,3441,3667,3361],0); -ELEMENTS[38625] = Fluid3D([3396,3441,3361,2998],0); -ELEMENTS[38626] = Fluid3D([3441,3667,3361,3851],0); -ELEMENTS[38627] = Fluid3D([3232,3681,3441,3307],0); -ELEMENTS[38628] = Fluid3D([3441,3232,3307,3296],0); -ELEMENTS[38629] = Fluid3D([3232,3307,3296,2948],0); -ELEMENTS[38630] = Fluid3D([3232,3307,2948,3290],0); -ELEMENTS[38631] = Fluid3D([3441,3232,3296,3072],0); -ELEMENTS[38632] = Fluid3D([3232,3296,3072,2948],0); -ELEMENTS[38633] = Fluid3D([3441,3232,3072,2998],0); -ELEMENTS[38634] = Fluid3D([3232,3307,3290,3681],0); -ELEMENTS[38635] = Fluid3D([3296,3441,3072,3269],0); -ELEMENTS[38636] = Fluid3D([2948,3232,3290,2998],0); -ELEMENTS[38637] = Fluid3D([3232,3072,2998,2948],0); -ELEMENTS[38638] = Fluid3D([8071,8959,8683,8246],0); -ELEMENTS[38639] = Fluid3D([8071,8959,8246,9035],0); -ELEMENTS[38640] = Fluid3D([8683,8071,8246,7572],0); -ELEMENTS[38641] = Fluid3D([8246,8071,9035,8294],0); -ELEMENTS[38642] = Fluid3D([8246,8071,8294,7236],0); -ELEMENTS[38643] = Fluid3D([9035,8246,8294,8299],0); -ELEMENTS[38644] = Fluid3D([8294,9035,8299,8895],0); -ELEMENTS[38645] = Fluid3D([8294,9035,8895,9488],0); -ELEMENTS[38646] = Fluid3D([8246,8071,7236,7572],0); -ELEMENTS[38647] = Fluid3D([8246,8294,8299,7344],0); -ELEMENTS[38648] = Fluid3D([5522,5068,4920,5433],0); -ELEMENTS[38649] = Fluid3D([14900,15170,15542,15290],0); -ELEMENTS[38650] = Fluid3D([5590,5617,5969,6090],0); -ELEMENTS[38651] = Fluid3D([7893,8414,8911,8722],0); -ELEMENTS[38652] = Fluid3D([8911,7893,8722,8569],0); -ELEMENTS[38653] = Fluid3D([8911,7893,8569,8517],0); -ELEMENTS[38654] = Fluid3D([8722,8911,8569,9259],0); -ELEMENTS[38655] = Fluid3D([8569,8911,8517,9020],0); -ELEMENTS[38656] = Fluid3D([8569,8911,9020,9259],0); -ELEMENTS[38657] = Fluid3D([8517,8569,9020,8201],0); -ELEMENTS[38658] = Fluid3D([8569,9020,8201,8655],0); -ELEMENTS[38659] = Fluid3D([8569,9020,8655,9259],0); -ELEMENTS[38660] = Fluid3D([9020,8201,8655,8374],0); -ELEMENTS[38661] = Fluid3D([8201,8569,8655,7478],0); -ELEMENTS[38662] = Fluid3D([13913,14580,14145,14519],0); -ELEMENTS[38663] = Fluid3D([8376,9042,8867,8015],0); -ELEMENTS[38664] = Fluid3D([17309,17255,17264,16871],0); -ELEMENTS[38665] = Fluid3D([15577,15830,16071,16189],0); -ELEMENTS[38666] = Fluid3D([14698,14377,14796,15324],0); -ELEMENTS[38667] = Fluid3D([5023,4578,5006,5178],0); -ELEMENTS[38668] = Fluid3D([1875,1744,1711,1717],0); -ELEMENTS[38669] = Fluid3D([13525,13798,12704,13402],0); -ELEMENTS[38670] = Fluid3D([10037,9564,9809,9113],0); -ELEMENTS[38671] = Fluid3D([9564,9809,9113,8649],0); -ELEMENTS[38672] = Fluid3D([9113,9564,8649,8884],0); -ELEMENTS[38673] = Fluid3D([9113,9564,8884,10037],0); -ELEMENTS[38674] = Fluid3D([8649,9113,8884,7880],0); -ELEMENTS[38675] = Fluid3D([9809,10037,9113,10401],0); -ELEMENTS[38676] = Fluid3D([2946,3017,3333,3179],0); -ELEMENTS[38677] = Fluid3D([3845,3861,3548,4089],0); -ELEMENTS[38678] = Fluid3D([4453,4291,4523,4851],0); -ELEMENTS[38679] = Fluid3D([12326,13113,12348,12711],0); -ELEMENTS[38680] = Fluid3D([13113,12348,12711,13528],0); -ELEMENTS[38681] = Fluid3D([12656,12620,12563,11693],0); -ELEMENTS[38682] = Fluid3D([12620,12563,11693,11526],0); -ELEMENTS[38683] = Fluid3D([12563,11693,11526,11818],0); -ELEMENTS[38684] = Fluid3D([11693,11526,11818,10739],0); -ELEMENTS[38685] = Fluid3D([10999,11902,11217,11485],0); -ELEMENTS[38686] = Fluid3D([17169,16869,17064,16858],0); -ELEMENTS[38687] = Fluid3D([18675,18691,18693,18695],0); -ELEMENTS[38688] = Fluid3D([18691,18693,18695,18698],0); -ELEMENTS[38689] = Fluid3D([18691,18693,18698,18692],0); -ELEMENTS[38690] = Fluid3D([18698,18691,18692,18696],0); -ELEMENTS[38691] = Fluid3D([17452,17151,17409,17138],0); -ELEMENTS[38692] = Fluid3D([6836,6417,7237,6854],0); -ELEMENTS[38693] = Fluid3D([6836,6417,6854,6088],0); -ELEMENTS[38694] = Fluid3D([6836,6417,6088,5758],0); -ELEMENTS[38695] = Fluid3D([3088,3081,3206,3391],0); -ELEMENTS[38696] = Fluid3D([3088,3081,3391,3260],0); -ELEMENTS[38697] = Fluid3D([5882,6522,6102,6808],0); -ELEMENTS[38698] = Fluid3D([3533,3132,3075,3142],0); -ELEMENTS[38699] = Fluid3D([8996,9593,8817,9854],0); -ELEMENTS[38700] = Fluid3D([14887,14787,14974,14132],0); -ELEMENTS[38701] = Fluid3D([2959,2728,2703,3189],0); -ELEMENTS[38702] = Fluid3D([4746,4741,5068,5331],0); -ELEMENTS[38703] = Fluid3D([1977,1966,2143,1976],0); -ELEMENTS[38704] = Fluid3D([2143,1977,1976,2037],0); -ELEMENTS[38705] = Fluid3D([1977,1976,2037,1873],0); -ELEMENTS[38706] = Fluid3D([1977,1966,1976,1829],0); -ELEMENTS[38707] = Fluid3D([2037,1977,1873,2083],0); -ELEMENTS[38708] = Fluid3D([9781,9532,10528,9852],0); -ELEMENTS[38709] = Fluid3D([14863,15213,15492,15683],0); -ELEMENTS[38710] = Fluid3D([16233,16780,16923,16596],0); -ELEMENTS[38711] = Fluid3D([16233,16780,16596,16620],0); -ELEMENTS[38712] = Fluid3D([16923,16233,16596,16509],0); -ELEMENTS[38713] = Fluid3D([16233,16596,16509,16040],0); -ELEMENTS[38714] = Fluid3D([16233,16596,16040,16011],0); -ELEMENTS[38715] = Fluid3D([16509,16233,16040,15865],0); -ELEMENTS[38716] = Fluid3D([16923,16233,16509,16396],0); -ELEMENTS[38717] = Fluid3D([16233,16596,16011,16620],0); -ELEMENTS[38718] = Fluid3D([16233,16040,15865,15572],0); -ELEMENTS[38719] = Fluid3D([16509,16233,15865,16396],0); -ELEMENTS[38720] = Fluid3D([16040,16233,16011,15687],0); -ELEMENTS[38721] = Fluid3D([5285,5064,4830,5355],0); -ELEMENTS[38722] = Fluid3D([13909,13893,14536,13984],0); -ELEMENTS[38723] = Fluid3D([13893,14536,13984,14766],0); -ELEMENTS[38724] = Fluid3D([8258,7778,8223,9090],0); -ELEMENTS[38725] = Fluid3D([4418,4314,4850,4595],0); -ELEMENTS[38726] = Fluid3D([7500,8249,8676,8073],0); -ELEMENTS[38727] = Fluid3D([7277,7139,7078,6519],0); -ELEMENTS[38728] = Fluid3D([7139,7078,6519,6512],0); -ELEMENTS[38729] = Fluid3D([7139,7078,6512,6572],0); -ELEMENTS[38730] = Fluid3D([7078,6519,6512,6000],0); -ELEMENTS[38731] = Fluid3D([6519,7139,6512,7277],0); -ELEMENTS[38732] = Fluid3D([6512,7139,6572,7969],0); -ELEMENTS[38733] = Fluid3D([7078,6512,6572,6563],0); -ELEMENTS[38734] = Fluid3D([6512,6572,6563,5843],0); -ELEMENTS[38735] = Fluid3D([6512,6572,5843,6247],0); -ELEMENTS[38736] = Fluid3D([9107,8054,8568,7832],0); -ELEMENTS[38737] = Fluid3D([8054,8568,7832,7402],0); -ELEMENTS[38738] = Fluid3D([11145,11948,10851,10874],0); -ELEMENTS[38739] = Fluid3D([2583,2687,2892,2635],0); -ELEMENTS[38740] = Fluid3D([10358,11007,11280,10181],0); -ELEMENTS[38741] = Fluid3D([14092,13240,13418,13214],0); -ELEMENTS[38742] = Fluid3D([7917,8121,7243,7516],0); -ELEMENTS[38743] = Fluid3D([7243,7917,7516,6855],0); -ELEMENTS[38744] = Fluid3D([15645,16099,15848,15443],0); -ELEMENTS[38745] = Fluid3D([15848,15645,15443,14892],0); -ELEMENTS[38746] = Fluid3D([15645,16099,15443,15491],0); -ELEMENTS[38747] = Fluid3D([15443,15645,15491,15014],0); -ELEMENTS[38748] = Fluid3D([15645,16099,15491,15515],0); -ELEMENTS[38749] = Fluid3D([16099,15443,15491,15746],0); -ELEMENTS[38750] = Fluid3D([15443,15491,15746,15074],0); -ELEMENTS[38751] = Fluid3D([15443,15491,15074,15014],0); -ELEMENTS[38752] = Fluid3D([15746,15443,15074,15298],0); -ELEMENTS[38753] = Fluid3D([15443,15074,15298,14892],0); -ELEMENTS[38754] = Fluid3D([15746,15443,15298,15893],0); -ELEMENTS[38755] = Fluid3D([15298,15746,15893,15843],0); -ELEMENTS[38756] = Fluid3D([15893,15298,15843,15643],0); -ELEMENTS[38757] = Fluid3D([15746,15443,15893,16099],0); -ELEMENTS[38758] = Fluid3D([15298,15746,15843,15782],0); -ELEMENTS[38759] = Fluid3D([15746,15843,15782,16402],0); -ELEMENTS[38760] = Fluid3D([15443,15298,15893,15367],0); -ELEMENTS[38761] = Fluid3D([15298,15893,15367,15643],0); -ELEMENTS[38762] = Fluid3D([15443,15298,15367,14892],0); -ELEMENTS[38763] = Fluid3D([15367,15443,14892,15848],0); -ELEMENTS[38764] = Fluid3D([15893,15443,15367,15848],0); -ELEMENTS[38765] = Fluid3D([15491,15746,15074,15589],0); -ELEMENTS[38766] = Fluid3D([15074,15746,15298,15050],0); -ELEMENTS[38767] = Fluid3D([15746,15893,15843,16607],0); -ELEMENTS[38768] = Fluid3D([15491,16099,15746,16055],0); -ELEMENTS[38769] = Fluid3D([16099,15746,16055,16607],0); -ELEMENTS[38770] = Fluid3D([15491,16099,16055,15515],0); -ELEMENTS[38771] = Fluid3D([16055,15491,15515,15589],0); -ELEMENTS[38772] = Fluid3D([15746,15491,16055,15589],0); -ELEMENTS[38773] = Fluid3D([15298,15843,15643,15278],0); -ELEMENTS[38774] = Fluid3D([15491,15515,15589,14844],0); -ELEMENTS[38775] = Fluid3D([15645,15491,15014,15515],0); -ELEMENTS[38776] = Fluid3D([9652,10173,10392,10825],0); -ELEMENTS[38777] = Fluid3D([5436,5875,5347,5806],0); -ELEMENTS[38778] = Fluid3D([13814,13300,13839,13970],0); -ELEMENTS[38779] = Fluid3D([13300,13839,13970,13503],0); -ELEMENTS[38780] = Fluid3D([13839,13970,13503,13703],0); -ELEMENTS[38781] = Fluid3D([13839,13814,13970,14632],0); -ELEMENTS[38782] = Fluid3D([13970,13839,14632,14458],0); -ELEMENTS[38783] = Fluid3D([13970,13839,14458,14301],0); -ELEMENTS[38784] = Fluid3D([13839,13970,13703,14301],0); -ELEMENTS[38785] = Fluid3D([11244,10613,10273,10400],0); -ELEMENTS[38786] = Fluid3D([15712,15015,15536,15617],0); -ELEMENTS[38787] = Fluid3D([3316,3466,3248,3597],0); -ELEMENTS[38788] = Fluid3D([3466,3248,3597,3797],0); -ELEMENTS[38789] = Fluid3D([3248,3316,3597,3174],0); -ELEMENTS[38790] = Fluid3D([3316,3466,3597,3696],0); -ELEMENTS[38791] = Fluid3D([16362,16670,16419,16176],0); -ELEMENTS[38792] = Fluid3D([10437,11049,10304,9996],0); -ELEMENTS[38793] = Fluid3D([10437,11049,9996,10732],0); -ELEMENTS[38794] = Fluid3D([10304,10437,9996,9139],0); -ELEMENTS[38795] = Fluid3D([5489,5789,5586,6234],0); -ELEMENTS[38796] = Fluid3D([14816,15347,14696,15489],0); -ELEMENTS[38797] = Fluid3D([12766,12104,11866,12499],0); -ELEMENTS[38798] = Fluid3D([16384,16170,16720,16434],0); -ELEMENTS[38799] = Fluid3D([12752,12855,13422,13245],0); -ELEMENTS[38800] = Fluid3D([12855,13422,13245,13468],0); -ELEMENTS[38801] = Fluid3D([16155,16423,16192,16889],0); -ELEMENTS[38802] = Fluid3D([8302,8574,7995,8918],0); -ELEMENTS[38803] = Fluid3D([13592,13007,13718,14259],0); -ELEMENTS[38804] = Fluid3D([11423,11895,10720,11474],0); -ELEMENTS[38805] = Fluid3D([5637,5677,6188,5657],0); -ELEMENTS[38806] = Fluid3D([8788,9475,9361,10114],0); -ELEMENTS[38807] = Fluid3D([2123,2196,1967,1992],0); -ELEMENTS[38808] = Fluid3D([8245,7532,8542,8058],0); -ELEMENTS[38809] = Fluid3D([15465,15300,15945,15405],0); -ELEMENTS[38810] = Fluid3D([9366,9709,10215,9320],0); -ELEMENTS[38811] = Fluid3D([10215,9366,9320,9661],0); -ELEMENTS[38812] = Fluid3D([9366,9709,9320,8591],0); -ELEMENTS[38813] = Fluid3D([10595,10900,11432,10848],0); -ELEMENTS[38814] = Fluid3D([17409,17138,17573,17452],0); -ELEMENTS[38815] = Fluid3D([13421,12586,13385,13110],0); -ELEMENTS[38816] = Fluid3D([10557,11540,10707,11506],0); -ELEMENTS[38817] = Fluid3D([8800,9329,9040,9748],0); -ELEMENTS[38818] = Fluid3D([11371,10594,10419,10994],0); -ELEMENTS[38819] = Fluid3D([7313,6909,7841,7539],0); -ELEMENTS[38820] = Fluid3D([14377,14478,14706,13872],0); -ELEMENTS[38821] = Fluid3D([13000,12920,13607,13587],0); -ELEMENTS[38822] = Fluid3D([10042,9096,9587,10023],0); -ELEMENTS[38823] = Fluid3D([3442,3874,3560,3676],0); -ELEMENTS[38824] = Fluid3D([15203,15346,15054,15824],0); -ELEMENTS[38825] = Fluid3D([3180,3147,3559,3355],0); -ELEMENTS[38826] = Fluid3D([5522,5050,5312,4920],0); -ELEMENTS[38827] = Fluid3D([5048,4993,5120,5615],0); -ELEMENTS[38828] = Fluid3D([15247,15196,15813,15407],0); -ELEMENTS[38829] = Fluid3D([16634,16916,16424,16382],0); -ELEMENTS[38830] = Fluid3D([16702,16689,16922,17327],0); -ELEMENTS[38831] = Fluid3D([6182,5796,6302,5754],0); -ELEMENTS[38832] = Fluid3D([6777,6304,6872,7561],0); -ELEMENTS[38833] = Fluid3D([12718,12432,11982,12939],0); -ELEMENTS[38834] = Fluid3D([5812,5919,5572,6303],0); -ELEMENTS[38835] = Fluid3D([15794,15680,16198,15825],0); -ELEMENTS[38836] = Fluid3D([15794,15680,15825,15213],0); -ELEMENTS[38837] = Fluid3D([15680,16198,15825,15683],0); -ELEMENTS[38838] = Fluid3D([15825,15680,15683,15213],0); -ELEMENTS[38839] = Fluid3D([15825,15794,15213,15492],0); -ELEMENTS[38840] = Fluid3D([17103,16928,16859,17204],0); -ELEMENTS[38841] = Fluid3D([2178,2338,2440,2292],0); -ELEMENTS[38842] = Fluid3D([8125,7623,8161,7167],0); -ELEMENTS[38843] = Fluid3D([18178,17901,17948,17840],0); -ELEMENTS[38844] = Fluid3D([14624,14511,14394,13701],0); -ELEMENTS[38845] = Fluid3D([4889,4292,4661,4559],0); -ELEMENTS[38846] = Fluid3D([4292,4661,4559,4238],0); -ELEMENTS[38847] = Fluid3D([4661,4559,4238,4829],0); -ELEMENTS[38848] = Fluid3D([4292,4661,4238,4276],0); -ELEMENTS[38849] = Fluid3D([4661,4559,4829,5090],0); -ELEMENTS[38850] = Fluid3D([4559,4292,4238,3911],0); -ELEMENTS[38851] = Fluid3D([4238,4559,3911,4485],0); -ELEMENTS[38852] = Fluid3D([4238,4559,4485,4829],0); -ELEMENTS[38853] = Fluid3D([4559,3911,4485,4289],0); -ELEMENTS[38854] = Fluid3D([4485,4559,4289,4864],0); -ELEMENTS[38855] = Fluid3D([4559,4289,4864,4603],0); -ELEMENTS[38856] = Fluid3D([4289,4864,4603,4486],0); -ELEMENTS[38857] = Fluid3D([4289,4864,4486,4485],0); -ELEMENTS[38858] = Fluid3D([4603,4289,4486,4271],0); -ELEMENTS[38859] = Fluid3D([4289,4486,4271,4126],0); -ELEMENTS[38860] = Fluid3D([4289,4486,4126,4485],0); -ELEMENTS[38861] = Fluid3D([4864,4603,4486,5077],0); -ELEMENTS[38862] = Fluid3D([4864,4559,4603,4889],0); -ELEMENTS[38863] = Fluid3D([4603,4289,4271,3911],0); -ELEMENTS[38864] = Fluid3D([4485,4559,4864,5090],0); -ELEMENTS[38865] = Fluid3D([4485,4559,5090,4829],0); -ELEMENTS[38866] = Fluid3D([4559,4289,4603,3911],0); -ELEMENTS[38867] = Fluid3D([4126,4289,4485,3911],0); -ELEMENTS[38868] = Fluid3D([4559,4864,5090,4889],0); -ELEMENTS[38869] = Fluid3D([4486,4603,4271,4592],0); -ELEMENTS[38870] = Fluid3D([4271,4486,4592,3984],0); -ELEMENTS[38871] = Fluid3D([4592,4271,3984,4058],0); -ELEMENTS[38872] = Fluid3D([4271,3984,4058,4084],0); -ELEMENTS[38873] = Fluid3D([4058,4271,4084,4592],0); -ELEMENTS[38874] = Fluid3D([4271,3984,4084,3964],0); -ELEMENTS[38875] = Fluid3D([4084,4271,3964,3911],0); -ELEMENTS[38876] = Fluid3D([4271,3984,3964,4126],0); -ELEMENTS[38877] = Fluid3D([4271,4084,4592,4603],0); -ELEMENTS[38878] = Fluid3D([4271,4084,4603,3911],0); -ELEMENTS[38879] = Fluid3D([4271,4486,3984,4126],0); -ELEMENTS[38880] = Fluid3D([3964,4271,4126,4289],0); -ELEMENTS[38881] = Fluid3D([4126,3964,4289,3911],0); -ELEMENTS[38882] = Fluid3D([3964,4271,4289,3911],0); -ELEMENTS[38883] = Fluid3D([4126,3964,3911,3550],0); -ELEMENTS[38884] = Fluid3D([3984,4058,4084,3747],0); -ELEMENTS[38885] = Fluid3D([4058,4084,3747,3540],0); -ELEMENTS[38886] = Fluid3D([4084,3747,3540,3530],0); -ELEMENTS[38887] = Fluid3D([3747,3540,3530,3434],0); -ELEMENTS[38888] = Fluid3D([3530,3747,3434,3984],0); -ELEMENTS[38889] = Fluid3D([3530,3747,3984,4084],0); -ELEMENTS[38890] = Fluid3D([3984,4058,3747,3822],0); -ELEMENTS[38891] = Fluid3D([4058,3747,3822,3540],0); -ELEMENTS[38892] = Fluid3D([3984,4058,3822,4356],0); -ELEMENTS[38893] = Fluid3D([4292,4238,3911,3835],0); -ELEMENTS[38894] = Fluid3D([4238,3911,3835,3752],0); -ELEMENTS[38895] = Fluid3D([4292,4238,3835,4276],0); -ELEMENTS[38896] = Fluid3D([4238,3835,4276,4173],0); -ELEMENTS[38897] = Fluid3D([4238,3835,4173,3752],0); -ELEMENTS[38898] = Fluid3D([4276,4238,4173,4661],0); -ELEMENTS[38899] = Fluid3D([4173,4238,3752,4485],0); -ELEMENTS[38900] = Fluid3D([4173,4238,4485,4829],0); -ELEMENTS[38901] = Fluid3D([4238,4173,4661,4829],0); -ELEMENTS[38902] = Fluid3D([4559,4292,3911,4603],0); -ELEMENTS[38903] = Fluid3D([4661,4889,4559,5090],0); -ELEMENTS[38904] = Fluid3D([3911,4238,4485,3752],0); -ELEMENTS[38905] = Fluid3D([3964,3911,3550,4084],0); -ELEMENTS[38906] = Fluid3D([3984,3964,4126,3530],0); -ELEMENTS[38907] = Fluid3D([3984,4592,4058,4356],0); -ELEMENTS[38908] = Fluid3D([9276,9084,8405,8410],0); -ELEMENTS[38909] = Fluid3D([10453,10893,9954,11152],0); -ELEMENTS[38910] = Fluid3D([8820,9177,9685,9837],0); -ELEMENTS[38911] = Fluid3D([13795,13500,13204,14150],0); -ELEMENTS[38912] = Fluid3D([13795,13500,14150,14363],0); -ELEMENTS[38913] = Fluid3D([13310,13434,13522,12578],0); -ELEMENTS[38914] = Fluid3D([10274,9907,10207,9286],0); -ELEMENTS[38915] = Fluid3D([3379,3114,3064,3564],0); -ELEMENTS[38916] = Fluid3D([16712,17087,17059,17224],0); -ELEMENTS[38917] = Fluid3D([17917,17991,17818,17450],0); -ELEMENTS[38918] = Fluid3D([4142,4416,4695,4233],0); -ELEMENTS[38919] = Fluid3D([4142,4416,4233,3962],0); -ELEMENTS[38920] = Fluid3D([4416,4695,4233,4365],0); -ELEMENTS[38921] = Fluid3D([15348,15629,15783,15291],0); -ELEMENTS[38922] = Fluid3D([14321,14625,14222,14604],0); -ELEMENTS[38923] = Fluid3D([14222,14321,14604,13637],0); -ELEMENTS[38924] = Fluid3D([12439,13280,12380,12523],0); -ELEMENTS[38925] = Fluid3D([12380,12439,12523,11642],0); -ELEMENTS[38926] = Fluid3D([13280,12380,12523,13367],0); -ELEMENTS[38927] = Fluid3D([4325,3881,4393,4208],0); -ELEMENTS[38928] = Fluid3D([4393,4325,4208,4825],0); -ELEMENTS[38929] = Fluid3D([4325,3881,4208,3980],0); -ELEMENTS[38930] = Fluid3D([15983,15822,15571,15526],0); -ELEMENTS[38931] = Fluid3D([15983,15822,15526,15999],0); -ELEMENTS[38932] = Fluid3D([10214,9771,9583,10862],0); -ELEMENTS[38933] = Fluid3D([18566,18501,18426,18437],0); -ELEMENTS[38934] = Fluid3D([1977,1808,1966,1829],0); -ELEMENTS[38935] = Fluid3D([15578,15638,16025,14997],0); -ELEMENTS[38936] = Fluid3D([7980,7761,7244,8193],0); -ELEMENTS[38937] = Fluid3D([17565,17608,17868,17863],0); -ELEMENTS[38938] = Fluid3D([11062,11149,11963,10711],0); -ELEMENTS[38939] = Fluid3D([11350,11728,10857,11656],0); -ELEMENTS[38940] = Fluid3D([18293,18434,18235,18287],0); -ELEMENTS[38941] = Fluid3D([12245,11956,11428,12481],0); -ELEMENTS[38942] = Fluid3D([7191,7140,6334,6441],0); -ELEMENTS[38943] = Fluid3D([7280,6608,6802,7747],0); -ELEMENTS[38944] = Fluid3D([8209,8799,9207,8649],0); -ELEMENTS[38945] = Fluid3D([13474,14109,13914,14320],0); -ELEMENTS[38946] = Fluid3D([6178,5809,6590,6583],0); -ELEMENTS[38947] = Fluid3D([6590,6178,6583,7185],0); -ELEMENTS[38948] = Fluid3D([6227,6742,6643,6969],0); -ELEMENTS[38949] = Fluid3D([13370,13248,13414,13998],0); -ELEMENTS[38950] = Fluid3D([13248,13414,13998,12702],0); -ELEMENTS[38951] = Fluid3D([6892,6918,6177,6081],0); -ELEMENTS[38952] = Fluid3D([12592,12932,13536,13051],0); -ELEMENTS[38953] = Fluid3D([3717,3670,3612,4318],0); -ELEMENTS[38954] = Fluid3D([7899,7650,7502,8618],0); -ELEMENTS[38955] = Fluid3D([6677,6197,5993,5830],0); -ELEMENTS[38956] = Fluid3D([13699,13186,12581,13266],0); -ELEMENTS[38957] = Fluid3D([7488,7390,7568,8219],0); -ELEMENTS[38958] = Fluid3D([7488,7390,8219,8007],0); -ELEMENTS[38959] = Fluid3D([7166,7332,7595,7909],0); -ELEMENTS[38960] = Fluid3D([7166,7332,7909,7746],0); -ELEMENTS[38961] = Fluid3D([7332,7909,7746,8030],0); -ELEMENTS[38962] = Fluid3D([7746,7332,8030,7089],0); -ELEMENTS[38963] = Fluid3D([7909,7746,8030,8304],0); -ELEMENTS[38964] = Fluid3D([7909,7746,8304,7166],0); -ELEMENTS[38965] = Fluid3D([8304,7909,7166,7791],0); -ELEMENTS[38966] = Fluid3D([7332,8030,7089,7598],0); -ELEMENTS[38967] = Fluid3D([7089,7332,7598,6763],0); -ELEMENTS[38968] = Fluid3D([7332,8030,7598,7595],0); -ELEMENTS[38969] = Fluid3D([8030,7089,7598,7727],0); -ELEMENTS[38970] = Fluid3D([7089,7598,7727,7378],0); -ELEMENTS[38971] = Fluid3D([7598,8030,7727,8399],0); -ELEMENTS[38972] = Fluid3D([7332,7909,8030,7595],0); -ELEMENTS[38973] = Fluid3D([7727,7598,8399,8124],0); -ELEMENTS[38974] = Fluid3D([7598,8399,8124,8485],0); -ELEMENTS[38975] = Fluid3D([8399,8124,8485,9286],0); -ELEMENTS[38976] = Fluid3D([7595,7166,7909,7791],0); -ELEMENTS[38977] = Fluid3D([7598,8399,8485,8030],0); -ELEMENTS[38978] = Fluid3D([8399,8485,8030,8871],0); -ELEMENTS[38979] = Fluid3D([8399,8485,8871,9400],0); -ELEMENTS[38980] = Fluid3D([8485,8030,8871,7909],0); -ELEMENTS[38981] = Fluid3D([8485,7598,8030,7595],0); -ELEMENTS[38982] = Fluid3D([8399,8485,9400,9286],0); -ELEMENTS[38983] = Fluid3D([8399,7727,8124,7378],0); -ELEMENTS[38984] = Fluid3D([7332,7598,6763,7595],0); -ELEMENTS[38985] = Fluid3D([8485,8871,9400,9131],0); -ELEMENTS[38986] = Fluid3D([8485,8871,9131,7909],0); -ELEMENTS[38987] = Fluid3D([8804,9359,9330,9175],0); -ELEMENTS[38988] = Fluid3D([13634,13063,12637,13257],0); -ELEMENTS[38989] = Fluid3D([13098,12312,12199,12010],0); -ELEMENTS[38990] = Fluid3D([17764,17842,17982,17530],0); -ELEMENTS[38991] = Fluid3D([17805,18026,17796,17947],0); -ELEMENTS[38992] = Fluid3D([16905,16723,16614,16436],0); -ELEMENTS[38993] = Fluid3D([17659,17841,17428,17798],0); -ELEMENTS[38994] = Fluid3D([9401,8763,9428,9054],0); -ELEMENTS[38995] = Fluid3D([9401,8763,9054,8158],0); -ELEMENTS[38996] = Fluid3D([9428,9401,9054,10252],0); -ELEMENTS[38997] = Fluid3D([9401,9054,10252,10009],0); -ELEMENTS[38998] = Fluid3D([9401,9054,10009,8709],0); -ELEMENTS[38999] = Fluid3D([11724,10780,11293,11904],0); -ELEMENTS[39000] = Fluid3D([7026,7313,7582,6539],0); -ELEMENTS[39001] = Fluid3D([7950,8050,8840,7883],0); -ELEMENTS[39002] = Fluid3D([6495,5952,6271,5803],0); -ELEMENTS[39003] = Fluid3D([9044,8740,8792,9787],0); -ELEMENTS[39004] = Fluid3D([8792,9044,9787,9243],0); -ELEMENTS[39005] = Fluid3D([9044,9787,9243,9627],0); -ELEMENTS[39006] = Fluid3D([9243,9044,9627,9908],0); -ELEMENTS[39007] = Fluid3D([9787,9243,9627,10352],0); -ELEMENTS[39008] = Fluid3D([9627,9243,9908,10352],0); -ELEMENTS[39009] = Fluid3D([9908,9627,10352,9465],0); -ELEMENTS[39010] = Fluid3D([9627,10352,9465,9787],0); -ELEMENTS[39011] = Fluid3D([9908,9627,9465,9044],0); -ELEMENTS[39012] = Fluid3D([9627,9465,9044,9787],0); -ELEMENTS[39013] = Fluid3D([8792,9044,9243,8446],0); -ELEMENTS[39014] = Fluid3D([9787,8792,9243,10184],0); -ELEMENTS[39015] = Fluid3D([9243,9787,10184,10352],0); -ELEMENTS[39016] = Fluid3D([9044,9243,8446,8907],0); -ELEMENTS[39017] = Fluid3D([9044,9243,8907,9908],0); -ELEMENTS[39018] = Fluid3D([9243,8446,8907,9661],0); -ELEMENTS[39019] = Fluid3D([16189,15928,15693,16360],0); -ELEMENTS[39020] = Fluid3D([18348,18237,18344,18448],0); -ELEMENTS[39021] = Fluid3D([15287,14853,15225,15723],0); -ELEMENTS[39022] = Fluid3D([16957,16976,16873,17446],0); -ELEMENTS[39023] = Fluid3D([4302,4603,4084,3911],0); -ELEMENTS[39024] = Fluid3D([12555,12444,12704,13402],0); -ELEMENTS[39025] = Fluid3D([16032,16011,16450,16620],0); -ELEMENTS[39026] = Fluid3D([14247,13885,13736,13449],0); -ELEMENTS[39027] = Fluid3D([5401,5204,5206,4662],0); -ELEMENTS[39028] = Fluid3D([3568,3478,3880,3902],0); -ELEMENTS[39029] = Fluid3D([6600,6893,7597,7200],0); -ELEMENTS[39030] = Fluid3D([6893,7597,7200,7698],0); -ELEMENTS[39031] = Fluid3D([7597,7200,7698,7777],0); -ELEMENTS[39032] = Fluid3D([7698,7597,7777,8220],0); -ELEMENTS[39033] = Fluid3D([7597,7200,7777,6600],0); -ELEMENTS[39034] = Fluid3D([6600,6893,7200,6868],0); -ELEMENTS[39035] = Fluid3D([7200,7698,7777,6736],0); -ELEMENTS[39036] = Fluid3D([11446,11021,11957,12025],0); -ELEMENTS[39037] = Fluid3D([12216,11895,11423,12849],0); -ELEMENTS[39038] = Fluid3D([8578,9437,8582,8704],0); -ELEMENTS[39039] = Fluid3D([18294,18183,18096,18410],0); -ELEMENTS[39040] = Fluid3D([6217,6559,6530,6890],0); -ELEMENTS[39041] = Fluid3D([6217,6559,6890,6250],0); -ELEMENTS[39042] = Fluid3D([6890,6217,6250,6297],0); -ELEMENTS[39043] = Fluid3D([6530,6217,6890,6402],0); -ELEMENTS[39044] = Fluid3D([13721,13693,14338,13518],0); -ELEMENTS[39045] = Fluid3D([8389,8122,8926,8885],0); -ELEMENTS[39046] = Fluid3D([8545,8196,8998,8462],0); -ELEMENTS[39047] = Fluid3D([17485,17053,17294,16998],0); -ELEMENTS[39048] = Fluid3D([13103,12089,12484,12681],0); -ELEMENTS[39049] = Fluid3D([11553,10904,11691,11618],0); -ELEMENTS[39050] = Fluid3D([17581,17612,17321,17651],0); -ELEMENTS[39051] = Fluid3D([17321,17581,17651,17245],0); -ELEMENTS[39052] = Fluid3D([17651,17321,17245,17390],0); -ELEMENTS[39053] = Fluid3D([17651,17321,17390,17612],0); -ELEMENTS[39054] = Fluid3D([17321,17245,17390,16885],0); -ELEMENTS[39055] = Fluid3D([17581,17612,17651,17945],0); -ELEMENTS[39056] = Fluid3D([11478,11549,10580,11395],0); -ELEMENTS[39057] = Fluid3D([14214,13990,13509,13919],0); -ELEMENTS[39058] = Fluid3D([14389,14055,14839,14510],0); -ELEMENTS[39059] = Fluid3D([6035,5813,6459,5788],0); -ELEMENTS[39060] = Fluid3D([2465,2670,2538,2927],0); -ELEMENTS[39061] = Fluid3D([2793,2618,2598,2401],0); -ELEMENTS[39062] = Fluid3D([5060,5267,4743,4810],0); -ELEMENTS[39063] = Fluid3D([4693,4923,5164,5258],0); -ELEMENTS[39064] = Fluid3D([4923,5164,5258,5422],0); -ELEMENTS[39065] = Fluid3D([5258,4923,5422,5303],0); -ELEMENTS[39066] = Fluid3D([4923,5422,5303,5778],0); -ELEMENTS[39067] = Fluid3D([5258,4923,5303,5229],0); -ELEMENTS[39068] = Fluid3D([5303,5258,5229,5824],0); -ELEMENTS[39069] = Fluid3D([5258,5229,5824,5566],0); -ELEMENTS[39070] = Fluid3D([5422,5258,5303,5995],0); -ELEMENTS[39071] = Fluid3D([5422,5303,5778,5995],0); -ELEMENTS[39072] = Fluid3D([4923,5164,5422,5345],0); -ELEMENTS[39073] = Fluid3D([4693,4923,5258,5229],0); -ELEMENTS[39074] = Fluid3D([5164,5258,5422,5610],0); -ELEMENTS[39075] = Fluid3D([4392,3989,4116,4569],0); -ELEMENTS[39076] = Fluid3D([4392,3989,4569,4482],0); -ELEMENTS[39077] = Fluid3D([8455,8330,8830,9210],0); -ELEMENTS[39078] = Fluid3D([8455,8330,9210,8492],0); -ELEMENTS[39079] = Fluid3D([8830,8455,9210,9265],0); -ELEMENTS[39080] = Fluid3D([16122,15949,16175,15354],0); -ELEMENTS[39081] = Fluid3D([12289,11148,11988,11879],0); -ELEMENTS[39082] = Fluid3D([16897,16786,17028,17222],0); -ELEMENTS[39083] = Fluid3D([16897,16786,17222,16967],0); -ELEMENTS[39084] = Fluid3D([16786,17028,17222,17219],0); -ELEMENTS[39085] = Fluid3D([15275,15212,15405,15838],0); -ELEMENTS[39086] = Fluid3D([11108,10365,11336,10714],0); -ELEMENTS[39087] = Fluid3D([2911,3008,3117,3492],0); -ELEMENTS[39088] = Fluid3D([7161,7214,6521,6926],0); -ELEMENTS[39089] = Fluid3D([17416,17205,17494,17399],0); -ELEMENTS[39090] = Fluid3D([9970,10943,10725,10642],0); -ELEMENTS[39091] = Fluid3D([9970,10943,10642,10536],0); -ELEMENTS[39092] = Fluid3D([10725,9970,10642,10271],0); -ELEMENTS[39093] = Fluid3D([10642,10725,10271,10975],0); -ELEMENTS[39094] = Fluid3D([13609,13135,13077,12476],0); -ELEMENTS[39095] = Fluid3D([11976,11842,12774,12602],0); -ELEMENTS[39096] = Fluid3D([5474,5944,6062,5681],0); -ELEMENTS[39097] = Fluid3D([12777,11838,12414,12481],0); -ELEMENTS[39098] = Fluid3D([12659,11783,12180,12126],0); -ELEMENTS[39099] = Fluid3D([11104,10202,10322,10778],0); -ELEMENTS[39100] = Fluid3D([12479,13274,13092,12212],0); -ELEMENTS[39101] = Fluid3D([17412,17450,17216,17814],0); -ELEMENTS[39102] = Fluid3D([4034,4360,4380,4003],0); -ELEMENTS[39103] = Fluid3D([11424,10790,11687,10699],0); -ELEMENTS[39104] = Fluid3D([16468,16519,16474,16913],0); -ELEMENTS[39105] = Fluid3D([13960,13527,14285,13374],0); -ELEMENTS[39106] = Fluid3D([5685,5513,5284,4832],0); -ELEMENTS[39107] = Fluid3D([5513,5284,4832,5272],0); -ELEMENTS[39108] = Fluid3D([5284,4832,5272,4774],0); -ELEMENTS[39109] = Fluid3D([4656,4384,4171,4352],0); -ELEMENTS[39110] = Fluid3D([13434,12939,13572,13411],0); -ELEMENTS[39111] = Fluid3D([16152,15574,15892,15508],0); -ELEMENTS[39112] = Fluid3D([15574,15892,15508,15184],0); -ELEMENTS[39113] = Fluid3D([15892,15508,15184,15682],0); -ELEMENTS[39114] = Fluid3D([16152,15574,15508,15718],0); -ELEMENTS[39115] = Fluid3D([15508,16152,15718,16266],0); -ELEMENTS[39116] = Fluid3D([9340,9470,8765,9617],0); -ELEMENTS[39117] = Fluid3D([5606,5470,5590,6091],0); -ELEMENTS[39118] = Fluid3D([16231,16147,15780,15871],0); -ELEMENTS[39119] = Fluid3D([16231,16147,15871,16591],0); -ELEMENTS[39120] = Fluid3D([11393,10898,12010,11442],0); -ELEMENTS[39121] = Fluid3D([7427,7537,6914,7678],0); -ELEMENTS[39122] = Fluid3D([4814,4564,4798,5329],0); -ELEMENTS[39123] = Fluid3D([8397,9095,8413,7860],0); -ELEMENTS[39124] = Fluid3D([7392,8136,8291,7712],0); -ELEMENTS[39125] = Fluid3D([17341,17715,17558,17419],0); -ELEMENTS[39126] = Fluid3D([8801,8007,8832,8406],0); -ELEMENTS[39127] = Fluid3D([12359,11380,11636,11546],0); -ELEMENTS[39128] = Fluid3D([18525,18464,18434,18287],0); -ELEMENTS[39129] = Fluid3D([6318,6055,5998,5457],0); -ELEMENTS[39130] = Fluid3D([6926,6583,6146,6028],0); -ELEMENTS[39131] = Fluid3D([12673,12472,13109,11832],0); -ELEMENTS[39132] = Fluid3D([12673,12472,11832,11709],0); -ELEMENTS[39133] = Fluid3D([8746,8276,9054,9428],0); -ELEMENTS[39134] = Fluid3D([14132,14486,13673,13717],0); -ELEMENTS[39135] = Fluid3D([13673,14132,13717,13451],0); -ELEMENTS[39136] = Fluid3D([16750,16641,16717,17123],0); -ELEMENTS[39137] = Fluid3D([4534,5047,5017,4731],0); -ELEMENTS[39138] = Fluid3D([2872,3113,3237,2827],0); -ELEMENTS[39139] = Fluid3D([6160,6935,6353,6912],0); -ELEMENTS[39140] = Fluid3D([10783,10458,11320,10313],0); -ELEMENTS[39141] = Fluid3D([9190,9385,9965,10293],0); -ELEMENTS[39142] = Fluid3D([12772,12640,13358,12419],0); -ELEMENTS[39143] = Fluid3D([5759,5754,5423,5313],0); -ELEMENTS[39144] = Fluid3D([5423,5759,5313,5278],0); -ELEMENTS[39145] = Fluid3D([5759,5313,5278,5804],0); -ELEMENTS[39146] = Fluid3D([5759,5754,5313,5613],0); -ELEMENTS[39147] = Fluid3D([5313,5759,5613,5804],0); -ELEMENTS[39148] = Fluid3D([16009,15631,16184,16403],0); -ELEMENTS[39149] = Fluid3D([17040,16875,16574,17038],0); -ELEMENTS[39150] = Fluid3D([6006,6709,5950,6100],0); -ELEMENTS[39151] = Fluid3D([6709,5950,6100,6696],0); -ELEMENTS[39152] = Fluid3D([10463,10264,9421,10422],0); -ELEMENTS[39153] = Fluid3D([12229,12637,12103,13155],0); -ELEMENTS[39154] = Fluid3D([13823,13952,13194,13098],0); -ELEMENTS[39155] = Fluid3D([17827,17673,17419,17715],0); -ELEMENTS[39156] = Fluid3D([17291,17415,16998,17174],0); -ELEMENTS[39157] = Fluid3D([16998,17291,17174,16801],0); -ELEMENTS[39158] = Fluid3D([17174,16998,16801,16512],0); -ELEMENTS[39159] = Fluid3D([16801,17174,16512,16779],0); -ELEMENTS[39160] = Fluid3D([16998,16801,16512,16560],0); -ELEMENTS[39161] = Fluid3D([16801,16512,16560,16202],0); -ELEMENTS[39162] = Fluid3D([16801,16512,16202,16672],0); -ELEMENTS[39163] = Fluid3D([16801,16512,16672,16779],0); -ELEMENTS[39164] = Fluid3D([16202,16801,16672,16945],0); -ELEMENTS[39165] = Fluid3D([16801,16672,16945,17180],0); -ELEMENTS[39166] = Fluid3D([16560,16801,16202,16945],0); -ELEMENTS[39167] = Fluid3D([16560,16801,16945,17116],0); -ELEMENTS[39168] = Fluid3D([16512,16560,16202,16178],0); -ELEMENTS[39169] = Fluid3D([16560,16202,16178,15840],0); -ELEMENTS[39170] = Fluid3D([17415,16998,17174,17485],0); -ELEMENTS[39171] = Fluid3D([16386,16383,15760,16235],0); -ELEMENTS[39172] = Fluid3D([14204,13895,14702,13746],0); -ELEMENTS[39173] = Fluid3D([13895,14702,13746,14201],0); -ELEMENTS[39174] = Fluid3D([9382,9754,8771,9687],0); -ELEMENTS[39175] = Fluid3D([10910,10719,11256,9968],0); -ELEMENTS[39176] = Fluid3D([6112,6367,5803,6495],0); -ELEMENTS[39177] = Fluid3D([10674,9636,9571,9398],0); -ELEMENTS[39178] = Fluid3D([7747,7357,8361,8117],0); -ELEMENTS[39179] = Fluid3D([3331,3812,3631,3666],0); -ELEMENTS[39180] = Fluid3D([3812,3631,3666,4071],0); -ELEMENTS[39181] = Fluid3D([3631,3331,3666,3300],0); -ELEMENTS[39182] = Fluid3D([10660,10303,11071,10258],0); -ELEMENTS[39183] = Fluid3D([10303,11071,10258,11219],0); -ELEMENTS[39184] = Fluid3D([11071,10660,10258,11168],0); -ELEMENTS[39185] = Fluid3D([15015,15403,15536,14548],0); -ELEMENTS[39186] = Fluid3D([10199,9566,10351,9940],0); -ELEMENTS[39187] = Fluid3D([6490,6174,6030,6308],0); -ELEMENTS[39188] = Fluid3D([6174,6030,6308,5398],0); -ELEMENTS[39189] = Fluid3D([18237,18139,18344,18048],0); -ELEMENTS[39190] = Fluid3D([18237,18139,18048,18015],0); -ELEMENTS[39191] = Fluid3D([18048,18237,18015,18312],0); -ELEMENTS[39192] = Fluid3D([18237,18015,18312,18266],0); -ELEMENTS[39193] = Fluid3D([16873,16976,17103,17446],0); -ELEMENTS[39194] = Fluid3D([14409,14292,15031,14739],0); -ELEMENTS[39195] = Fluid3D([15829,15968,16350,16384],0); -ELEMENTS[39196] = Fluid3D([16467,16189,16707,16896],0); -ELEMENTS[39197] = Fluid3D([5301,5688,5238,5175],0); -ELEMENTS[39198] = Fluid3D([13217,12319,12857,12269],0); -ELEMENTS[39199] = Fluid3D([12319,12857,12269,11977],0); -ELEMENTS[39200] = Fluid3D([13217,12319,12269,12064],0); -ELEMENTS[39201] = Fluid3D([3347,3274,3259,2961],0); -ELEMENTS[39202] = Fluid3D([3259,3347,2961,3128],0); -ELEMENTS[39203] = Fluid3D([3347,3274,2961,3155],0); -ELEMENTS[39204] = Fluid3D([7594,7632,8206,7274],0); -ELEMENTS[39205] = Fluid3D([8546,8205,7848,8176],0); -ELEMENTS[39206] = Fluid3D([9568,9014,9088,8645],0); -ELEMENTS[39207] = Fluid3D([9568,9014,8645,9135],0); -ELEMENTS[39208] = Fluid3D([2262,2033,1989,2075],0); -ELEMENTS[39209] = Fluid3D([16320,16511,15945,16415],0); -ELEMENTS[39210] = Fluid3D([8823,9491,9788,8591],0); -ELEMENTS[39211] = Fluid3D([7584,6807,7117,6538],0); -ELEMENTS[39212] = Fluid3D([15446,15155,15384,15826],0); -ELEMENTS[39213] = Fluid3D([8344,8966,9319,9119],0); -ELEMENTS[39214] = Fluid3D([8966,9319,9119,9839],0); -ELEMENTS[39215] = Fluid3D([9319,9119,9839,9113],0); -ELEMENTS[39216] = Fluid3D([8344,8966,9119,8296],0); -ELEMENTS[39217] = Fluid3D([12484,12681,13366,13103],0); -ELEMENTS[39218] = Fluid3D([10560,9837,10940,10398],0); -ELEMENTS[39219] = Fluid3D([11701,12021,11209,10550],0); -ELEMENTS[39220] = Fluid3D([10374,10922,9692,10188],0); -ELEMENTS[39221] = Fluid3D([15930,16342,16471,16486],0); -ELEMENTS[39222] = Fluid3D([11003,10390,10414,10085],0); -ELEMENTS[39223] = Fluid3D([2432,2326,2592,2638],0); -ELEMENTS[39224] = Fluid3D([2592,2432,2638,2794],0); -ELEMENTS[39225] = Fluid3D([2432,2326,2638,2260],0); -ELEMENTS[39226] = Fluid3D([3318,3172,3512,3281],0); -ELEMENTS[39227] = Fluid3D([3172,3512,3281,3473],0); -ELEMENTS[39228] = Fluid3D([3512,3318,3281,3462],0); -ELEMENTS[39229] = Fluid3D([3318,3172,3281,2910],0); -ELEMENTS[39230] = Fluid3D([5349,4922,4957,4940],0); -ELEMENTS[39231] = Fluid3D([4845,5352,4937,5382],0); -ELEMENTS[39232] = Fluid3D([4841,4307,4699,4746],0); -ELEMENTS[39233] = Fluid3D([15241,14872,15624,15524],0); -ELEMENTS[39234] = Fluid3D([9644,9585,10368,10461],0); -ELEMENTS[39235] = Fluid3D([14709,14931,15417,15301],0); -ELEMENTS[39236] = Fluid3D([5052,5089,5399,4767],0); -ELEMENTS[39237] = Fluid3D([4048,3996,4431,3876],0); -ELEMENTS[39238] = Fluid3D([11473,11978,11847,10638],0); -ELEMENTS[39239] = Fluid3D([16601,16660,16327,16979],0); -ELEMENTS[39240] = Fluid3D([2648,2926,2639,3053],0); -ELEMENTS[39241] = Fluid3D([10365,9387,9717,10184],0); -ELEMENTS[39242] = Fluid3D([13624,13591,12866,13642],0); -ELEMENTS[39243] = Fluid3D([10414,11129,11022,10587],0); -ELEMENTS[39244] = Fluid3D([15797,15738,16202,15625],0); -ELEMENTS[39245] = Fluid3D([17936,18208,18101,18264],0); -ELEMENTS[39246] = Fluid3D([11215,11261,10408,10964],0); -ELEMENTS[39247] = Fluid3D([11215,11261,10964,11777],0); -ELEMENTS[39248] = Fluid3D([11261,10964,11777,11087],0); -ELEMENTS[39249] = Fluid3D([11261,10964,11087,10289],0); -ELEMENTS[39250] = Fluid3D([11261,10964,10289,10408],0); -ELEMENTS[39251] = Fluid3D([10289,11261,10408,10795],0); -ELEMENTS[39252] = Fluid3D([10235,10005,11034,10538],0); -ELEMENTS[39253] = Fluid3D([7429,7121,7519,7932],0); -ELEMENTS[39254] = Fluid3D([5955,6349,6253,5755],0); -ELEMENTS[39255] = Fluid3D([6253,5955,5755,5295],0); -ELEMENTS[39256] = Fluid3D([5955,5755,5295,5369],0); -ELEMENTS[39257] = Fluid3D([5755,5295,5369,5251],0); -ELEMENTS[39258] = Fluid3D([5955,6349,5755,5369],0); -ELEMENTS[39259] = Fluid3D([14583,13761,14231,13809],0); -ELEMENTS[39260] = Fluid3D([15953,15378,16035,15585],0); -ELEMENTS[39261] = Fluid3D([3688,4017,3816,3515],0); -ELEMENTS[39262] = Fluid3D([13409,13346,13090,14385],0); -ELEMENTS[39263] = Fluid3D([16699,16978,16915,16449],0); -ELEMENTS[39264] = Fluid3D([13449,13038,13422,14128],0); -ELEMENTS[39265] = Fluid3D([16625,16812,17139,17115],0); -ELEMENTS[39266] = Fluid3D([15763,15496,16050,16168],0); -ELEMENTS[39267] = Fluid3D([16050,15763,16168,16420],0); -ELEMENTS[39268] = Fluid3D([14480,14105,13805,13964],0); -ELEMENTS[39269] = Fluid3D([5460,4950,5546,5043],0); -ELEMENTS[39270] = Fluid3D([15763,16160,16033,16420],0); -ELEMENTS[39271] = Fluid3D([9551,9180,8616,9502],0); -ELEMENTS[39272] = Fluid3D([8616,9551,9502,9288],0); -ELEMENTS[39273] = Fluid3D([9551,9502,9288,10359],0); -ELEMENTS[39274] = Fluid3D([9551,9180,9502,10027],0); -ELEMENTS[39275] = Fluid3D([9502,8616,9288,9036],0); -ELEMENTS[39276] = Fluid3D([9288,9502,9036,9722],0); -ELEMENTS[39277] = Fluid3D([9036,9288,9722,9039],0); -ELEMENTS[39278] = Fluid3D([8616,9551,9288,8542],0); -ELEMENTS[39279] = Fluid3D([9288,8616,8542,9036],0); -ELEMENTS[39280] = Fluid3D([8542,9288,9036,8491],0); -ELEMENTS[39281] = Fluid3D([8616,9551,8542,9086],0); -ELEMENTS[39282] = Fluid3D([13788,13847,14594,14094],0); -ELEMENTS[39283] = Fluid3D([18535,18371,18450,18478],0); -ELEMENTS[39284] = Fluid3D([17591,17666,17252,17510],0); -ELEMENTS[39285] = Fluid3D([6386,6180,6911,7244],0); -ELEMENTS[39286] = Fluid3D([11816,12454,11694,12583],0); -ELEMENTS[39287] = Fluid3D([11460,12076,12217,11559],0); -ELEMENTS[39288] = Fluid3D([6654,6375,7264,6629],0); -ELEMENTS[39289] = Fluid3D([6654,6375,6629,5921],0); -ELEMENTS[39290] = Fluid3D([6629,6654,5921,6161],0); -ELEMENTS[39291] = Fluid3D([7264,6654,6629,7196],0); -ELEMENTS[39292] = Fluid3D([6654,6629,7196,6817],0); -ELEMENTS[39293] = Fluid3D([6654,6629,6817,6161],0); -ELEMENTS[39294] = Fluid3D([7196,6654,6817,7635],0); -ELEMENTS[39295] = Fluid3D([6817,7196,7635,6976],0); -ELEMENTS[39296] = Fluid3D([6375,6629,5921,6201],0); -ELEMENTS[39297] = Fluid3D([6629,5921,6201,5797],0); -ELEMENTS[39298] = Fluid3D([6629,5921,5797,6161],0); -ELEMENTS[39299] = Fluid3D([5921,5797,6161,5781],0); -ELEMENTS[39300] = Fluid3D([7264,6654,7196,7635],0); -ELEMENTS[39301] = Fluid3D([5921,6201,5797,5393],0); -ELEMENTS[39302] = Fluid3D([5797,5921,5393,5781],0); -ELEMENTS[39303] = Fluid3D([6629,7196,6817,6976],0); -ELEMENTS[39304] = Fluid3D([11210,11116,11934,11103],0); -ELEMENTS[39305] = Fluid3D([7844,7184,7450,6946],0); -ELEMENTS[39306] = Fluid3D([6556,7007,6562,6204],0); -ELEMENTS[39307] = Fluid3D([11710,11986,11311,12307],0); -ELEMENTS[39308] = Fluid3D([11311,11710,12307,11413],0); -ELEMENTS[39309] = Fluid3D([11710,11986,12307,12644],0); -ELEMENTS[39310] = Fluid3D([15432,15318,15036,15740],0); -ELEMENTS[39311] = Fluid3D([15318,15036,15740,15852],0); -ELEMENTS[39312] = Fluid3D([15432,15318,15740,15810],0); -ELEMENTS[39313] = Fluid3D([14188,13963,14176,14788],0); -ELEMENTS[39314] = Fluid3D([13886,13308,13680,12935],0); -ELEMENTS[39315] = Fluid3D([3507,3176,3378,3074],0); -ELEMENTS[39316] = Fluid3D([6192,5585,5889,5787],0); -ELEMENTS[39317] = Fluid3D([3988,3739,3808,4268],0); -ELEMENTS[39318] = Fluid3D([11541,12515,12263,11844],0); -ELEMENTS[39319] = Fluid3D([11541,12515,11844,11903],0); -ELEMENTS[39320] = Fluid3D([12515,11844,11903,12888],0); -ELEMENTS[39321] = Fluid3D([11844,11903,12888,12049],0); -ELEMENTS[39322] = Fluid3D([11844,11903,12049,11027],0); -ELEMENTS[39323] = Fluid3D([11844,11903,11027,10897],0); -ELEMENTS[39324] = Fluid3D([12049,11844,11027,11457],0); -ELEMENTS[39325] = Fluid3D([12049,11844,11457,12263],0); -ELEMENTS[39326] = Fluid3D([11844,11457,12263,11541],0); -ELEMENTS[39327] = Fluid3D([12888,11844,12049,13119],0); -ELEMENTS[39328] = Fluid3D([12515,12263,11844,13119],0); -ELEMENTS[39329] = Fluid3D([11844,11027,11457,11541],0); -ELEMENTS[39330] = Fluid3D([12049,11844,12263,13119],0); -ELEMENTS[39331] = Fluid3D([13153,13140,13484,14003],0); -ELEMENTS[39332] = Fluid3D([4783,5355,5040,4912],0); -ELEMENTS[39333] = Fluid3D([5737,6160,5744,5591],0); -ELEMENTS[39334] = Fluid3D([15795,15200,15435,15573],0); -ELEMENTS[39335] = Fluid3D([14886,14976,14611,14143],0); -ELEMENTS[39336] = Fluid3D([14976,14611,14143,14557],0); -ELEMENTS[39337] = Fluid3D([9704,9217,9945,10142],0); -ELEMENTS[39338] = Fluid3D([17134,17031,17046,16650],0); -ELEMENTS[39339] = Fluid3D([7653,8202,7147,7586],0); -ELEMENTS[39340] = Fluid3D([9689,8927,9142,10001],0); -ELEMENTS[39341] = Fluid3D([13952,13978,13194,13749],0); -ELEMENTS[39342] = Fluid3D([10839,11511,10838,11482],0); -ELEMENTS[39343] = Fluid3D([10839,11511,11482,11133],0); -ELEMENTS[39344] = Fluid3D([11511,10838,11482,11845],0); -ELEMENTS[39345] = Fluid3D([3565,3148,3295,3320],0); -ELEMENTS[39346] = Fluid3D([3565,3148,3320,3290],0); -ELEMENTS[39347] = Fluid3D([3148,3320,3290,2978],0); -ELEMENTS[39348] = Fluid3D([17840,17924,17960,18160],0); -ELEMENTS[39349] = Fluid3D([17840,17924,18160,17879],0); -ELEMENTS[39350] = Fluid3D([17924,18160,17879,17986],0); -ELEMENTS[39351] = Fluid3D([17924,18160,17986,18039],0); -ELEMENTS[39352] = Fluid3D([9087,8863,9157,10061],0); -ELEMENTS[39353] = Fluid3D([9385,9190,9519,10293],0); -ELEMENTS[39354] = Fluid3D([6952,6652,6187,7211],0); -ELEMENTS[39355] = Fluid3D([9239,10112,9776,9368],0); -ELEMENTS[39356] = Fluid3D([14882,15391,15108,15667],0); -ELEMENTS[39357] = Fluid3D([10909,11522,11463,10856],0); -ELEMENTS[39358] = Fluid3D([17627,17660,17383,17808],0); -ELEMENTS[39359] = Fluid3D([17627,17660,17808,17983],0); -ELEMENTS[39360] = Fluid3D([4039,4304,4545,4356],0); -ELEMENTS[39361] = Fluid3D([9551,9901,10632,10359],0); -ELEMENTS[39362] = Fluid3D([2237,2220,2471,2365],0); -ELEMENTS[39363] = Fluid3D([15587,15716,15609,16137],0); -ELEMENTS[39364] = Fluid3D([14156,13272,14019,13879],0); -ELEMENTS[39365] = Fluid3D([13046,13742,13145,13898],0); -ELEMENTS[39366] = Fluid3D([3483,3781,3328,3610],0); -ELEMENTS[39367] = Fluid3D([3328,3483,3610,3230],0); -ELEMENTS[39368] = Fluid3D([3328,3483,3230,2985],0); -ELEMENTS[39369] = Fluid3D([3483,3610,3230,3508],0); -ELEMENTS[39370] = Fluid3D([3591,3314,3725,3830],0); -ELEMENTS[39371] = Fluid3D([7511,8233,8256,7928],0); -ELEMENTS[39372] = Fluid3D([11997,11951,12298,12767],0); -ELEMENTS[39373] = Fluid3D([6132,6002,6370,6491],0); -ELEMENTS[39374] = Fluid3D([10761,10854,9859,10123],0); -ELEMENTS[39375] = Fluid3D([9859,10761,10123,10154],0); -ELEMENTS[39376] = Fluid3D([10761,10123,10154,10953],0); -ELEMENTS[39377] = Fluid3D([10154,10761,10953,11002],0); -ELEMENTS[39378] = Fluid3D([10154,10761,11002,10516],0); -ELEMENTS[39379] = Fluid3D([10761,10123,10953,11231],0); -ELEMENTS[39380] = Fluid3D([10154,10761,10516,9859],0); -ELEMENTS[39381] = Fluid3D([10953,10761,11231,12032],0); -ELEMENTS[39382] = Fluid3D([10761,10953,11002,12032],0); -ELEMENTS[39383] = Fluid3D([10123,9859,10154,9082],0); -ELEMENTS[39384] = Fluid3D([18230,18213,17979,18172],0); -ELEMENTS[39385] = Fluid3D([17322,17563,17744,17370],0); -ELEMENTS[39386] = Fluid3D([9247,10007,10149,9556],0); -ELEMENTS[39387] = Fluid3D([5595,6150,5969,5419],0); -ELEMENTS[39388] = Fluid3D([13740,13313,13940,14427],0); -ELEMENTS[39389] = Fluid3D([12224,11963,11429,11769],0); -ELEMENTS[39390] = Fluid3D([11429,12224,11769,12325],0); -ELEMENTS[39391] = Fluid3D([12224,11769,12325,12592],0); -ELEMENTS[39392] = Fluid3D([16067,16336,16458,16600],0); -ELEMENTS[39393] = Fluid3D([16336,16458,16600,16817],0); -ELEMENTS[39394] = Fluid3D([16458,16067,16600,16679],0); -ELEMENTS[39395] = Fluid3D([16600,16458,16679,16996],0); -ELEMENTS[39396] = Fluid3D([16679,16600,16996,16955],0); -ELEMENTS[39397] = Fluid3D([16679,16600,16955,16632],0); -ELEMENTS[39398] = Fluid3D([16458,16067,16679,16346],0); -ELEMENTS[39399] = Fluid3D([16600,16996,16955,16744],0); -ELEMENTS[39400] = Fluid3D([16067,16600,16679,16632],0); -ELEMENTS[39401] = Fluid3D([16955,16600,16744,16515],0); -ELEMENTS[39402] = Fluid3D([16600,16744,16515,16108],0); -ELEMENTS[39403] = Fluid3D([16744,16515,16108,16363],0); -ELEMENTS[39404] = Fluid3D([16600,16336,16817,16744],0); -ELEMENTS[39405] = Fluid3D([16817,16600,16744,16996],0); -ELEMENTS[39406] = Fluid3D([16817,16600,16996,16458],0); -ELEMENTS[39407] = Fluid3D([16744,16817,16996,17235],0); -ELEMENTS[39408] = Fluid3D([16817,16996,17235,17284],0); -ELEMENTS[39409] = Fluid3D([16817,16996,16733,16458],0); -ELEMENTS[39410] = Fluid3D([12246,11490,12047,12414],0); -ELEMENTS[39411] = Fluid3D([17788,17716,17793,17420],0); -ELEMENTS[39412] = Fluid3D([7140,7122,6819,7895],0); -ELEMENTS[39413] = Fluid3D([9442,10128,10772,10115],0); -ELEMENTS[39414] = Fluid3D([8978,8209,9207,8734],0); -ELEMENTS[39415] = Fluid3D([15307,15935,15497,15493],0); -ELEMENTS[39416] = Fluid3D([3052,3457,3208,3082],0); -ELEMENTS[39417] = Fluid3D([14468,14959,15056,14477],0); -ELEMENTS[39418] = Fluid3D([6224,6177,5611,6137],0); -ELEMENTS[39419] = Fluid3D([14803,15347,15076,14696],0); -ELEMENTS[39420] = Fluid3D([15076,14803,14696,14246],0); -ELEMENTS[39421] = Fluid3D([15076,14803,14246,14257],0); -ELEMENTS[39422] = Fluid3D([6814,6305,5959,6617],0); -ELEMENTS[39423] = Fluid3D([8635,8412,8629,9544],0); -ELEMENTS[39424] = Fluid3D([7905,7692,7578,7043],0); -ELEMENTS[39425] = Fluid3D([12247,12335,13100,13252],0); -ELEMENTS[39426] = Fluid3D([4218,3848,3767,4029],0); -ELEMENTS[39427] = Fluid3D([7408,8305,7767,7869],0); -ELEMENTS[39428] = Fluid3D([11843,11130,12057,11423],0); -ELEMENTS[39429] = Fluid3D([14879,15557,15126,15357],0); -ELEMENTS[39430] = Fluid3D([15126,14879,15357,14997],0); -ELEMENTS[39431] = Fluid3D([15357,15126,14997,15596],0); -ELEMENTS[39432] = Fluid3D([14997,15357,15596,16025],0); -ELEMENTS[39433] = Fluid3D([14879,15557,15357,15139],0); -ELEMENTS[39434] = Fluid3D([15357,14879,15139,14997],0); -ELEMENTS[39435] = Fluid3D([15357,15126,15596,15557],0); -ELEMENTS[39436] = Fluid3D([7918,8373,8294,7446],0); -ELEMENTS[39437] = Fluid3D([7134,7497,7794,7016],0); -ELEMENTS[39438] = Fluid3D([7794,7134,7016,7124],0); -ELEMENTS[39439] = Fluid3D([7134,7497,7016,6437],0); -ELEMENTS[39440] = Fluid3D([11124,10120,9908,10672],0); -ELEMENTS[39441] = Fluid3D([11124,10120,10672,10768],0); -ELEMENTS[39442] = Fluid3D([10672,11124,10768,11908],0); -ELEMENTS[39443] = Fluid3D([10120,10672,10768,9615],0); -ELEMENTS[39444] = Fluid3D([9908,11124,10672,11230],0); -ELEMENTS[39445] = Fluid3D([10120,9908,10672,9816],0); -ELEMENTS[39446] = Fluid3D([9908,10672,9816,11230],0); -ELEMENTS[39447] = Fluid3D([15478,14849,15353,15767],0); -ELEMENTS[39448] = Fluid3D([12431,11665,12318,11961],0); -ELEMENTS[39449] = Fluid3D([12431,11665,11961,11743],0); -ELEMENTS[39450] = Fluid3D([17310,17527,17229,17628],0); -ELEMENTS[39451] = Fluid3D([17120,17051,17187,16739],0); -ELEMENTS[39452] = Fluid3D([17051,17187,16739,16619],0); -ELEMENTS[39453] = Fluid3D([17120,17051,16739,16465],0); -ELEMENTS[39454] = Fluid3D([17187,16739,16619,16950],0); -ELEMENTS[39455] = Fluid3D([4153,3904,3868,4177],0); -ELEMENTS[39456] = Fluid3D([4153,3904,4177,4296],0); -ELEMENTS[39457] = Fluid3D([3904,4177,4296,3700],0); -ELEMENTS[39458] = Fluid3D([3868,4153,4177,4322],0); -ELEMENTS[39459] = Fluid3D([4153,4177,4322,4638],0); -ELEMENTS[39460] = Fluid3D([4177,4322,4638,4351],0); -ELEMENTS[39461] = Fluid3D([4177,4322,4351,3868],0); -ELEMENTS[39462] = Fluid3D([4322,4638,4351,4425],0); -ELEMENTS[39463] = Fluid3D([4322,4638,4425,4832],0); -ELEMENTS[39464] = Fluid3D([4638,4177,4351,4753],0); -ELEMENTS[39465] = Fluid3D([4351,4177,3868,3700],0); -ELEMENTS[39466] = Fluid3D([4351,4322,4425,3974],0); -ELEMENTS[39467] = Fluid3D([4351,4322,3974,3868],0); -ELEMENTS[39468] = Fluid3D([3974,4351,3868,3700],0); -ELEMENTS[39469] = Fluid3D([3868,3974,3700,3373],0); -ELEMENTS[39470] = Fluid3D([3974,4351,3700,4116],0); -ELEMENTS[39471] = Fluid3D([3974,4351,4116,4214],0); -ELEMENTS[39472] = Fluid3D([3974,4351,4214,4259],0); -ELEMENTS[39473] = Fluid3D([4322,3974,3868,4425],0); -ELEMENTS[39474] = Fluid3D([4351,4116,4214,4569],0); -ELEMENTS[39475] = Fluid3D([3868,4153,4322,4425],0); -ELEMENTS[39476] = Fluid3D([4322,4638,4832,4153],0); -ELEMENTS[39477] = Fluid3D([4351,4177,3700,4116],0); -ELEMENTS[39478] = Fluid3D([4351,4177,4116,4296],0); -ELEMENTS[39479] = Fluid3D([4351,4177,4296,4753],0); -ELEMENTS[39480] = Fluid3D([4177,4296,4753,4153],0); -ELEMENTS[39481] = Fluid3D([4177,3868,3700,3904],0); -ELEMENTS[39482] = Fluid3D([12764,13127,12283,13012],0); -ELEMENTS[39483] = Fluid3D([12777,13007,12428,13718],0); -ELEMENTS[39484] = Fluid3D([7280,6802,7711,7747],0); -ELEMENTS[39485] = Fluid3D([13951,13305,14068,13829],0); -ELEMENTS[39486] = Fluid3D([13745,13607,12920,14174],0); -ELEMENTS[39487] = Fluid3D([10592,10965,11603,11009],0); -ELEMENTS[39488] = Fluid3D([3908,3960,3518,3692],0); -ELEMENTS[39489] = Fluid3D([3768,4202,3559,3940],0); -ELEMENTS[39490] = Fluid3D([17753,17481,17740,17257],0); -ELEMENTS[39491] = Fluid3D([7090,7467,8062,7775],0); -ELEMENTS[39492] = Fluid3D([5068,5050,4920,4579],0); -ELEMENTS[39493] = Fluid3D([5068,5050,4579,4746],0); -ELEMENTS[39494] = Fluid3D([5243,5621,5099,5803],0); -ELEMENTS[39495] = Fluid3D([10671,10851,11096,11932],0); -ELEMENTS[39496] = Fluid3D([14143,13460,13462,13661],0); -ELEMENTS[39497] = Fluid3D([12713,13200,13401,12952],0); -ELEMENTS[39498] = Fluid3D([13401,12713,12952,13060],0); -ELEMENTS[39499] = Fluid3D([12952,13401,13060,13263],0); -ELEMENTS[39500] = Fluid3D([12713,13200,12952,12278],0); -ELEMENTS[39501] = Fluid3D([12952,12713,12278,13060],0); -ELEMENTS[39502] = Fluid3D([13200,12952,12278,13263],0); -ELEMENTS[39503] = Fluid3D([13200,12952,13263,13401],0); -ELEMENTS[39504] = Fluid3D([12952,12278,13263,12867],0); -ELEMENTS[39505] = Fluid3D([13263,12952,12867,13060],0); -ELEMENTS[39506] = Fluid3D([12952,12278,12867,13060],0); -ELEMENTS[39507] = Fluid3D([12278,13200,13263,12734],0); -ELEMENTS[39508] = Fluid3D([13200,13263,12734,13915],0); -ELEMENTS[39509] = Fluid3D([13200,13263,13915,14487],0); -ELEMENTS[39510] = Fluid3D([13263,13200,13401,14184],0); -ELEMENTS[39511] = Fluid3D([3904,3719,3868,3320],0); -ELEMENTS[39512] = Fluid3D([17275,17536,17338,17656],0); -ELEMENTS[39513] = Fluid3D([5227,5152,5335,4731],0); -ELEMENTS[39514] = Fluid3D([10468,11505,10911,10517],0); -ELEMENTS[39515] = Fluid3D([5477,5264,5178,4718],0); -ELEMENTS[39516] = Fluid3D([16783,16870,17248,17258],0); -ELEMENTS[39517] = Fluid3D([9708,9876,9149,10057],0); -ELEMENTS[39518] = Fluid3D([7279,7706,7509,6697],0); -ELEMENTS[39519] = Fluid3D([7509,7279,6697,6771],0); -ELEMENTS[39520] = Fluid3D([11996,12950,12541,12652],0); -ELEMENTS[39521] = Fluid3D([11479,11974,12540,12258],0); -ELEMENTS[39522] = Fluid3D([13563,13240,13011,13877],0); -ELEMENTS[39523] = Fluid3D([16247,15970,16407,16552],0); -ELEMENTS[39524] = Fluid3D([15076,14246,14447,14257],0); -ELEMENTS[39525] = Fluid3D([6966,7541,7403,6821],0); -ELEMENTS[39526] = Fluid3D([13402,13645,13758,12555],0); -ELEMENTS[39527] = Fluid3D([5130,4625,4666,5100],0); -ELEMENTS[39528] = Fluid3D([5511,5218,5679,5075],0); -ELEMENTS[39529] = Fluid3D([6321,5915,5516,5857],0); -ELEMENTS[39530] = Fluid3D([4965,5073,4806,4564],0); -ELEMENTS[39531] = Fluid3D([7665,7919,8438,7856],0); -ELEMENTS[39532] = Fluid3D([6194,6949,6543,7213],0); -ELEMENTS[39533] = Fluid3D([10048,9644,9608,8666],0); -ELEMENTS[39534] = Fluid3D([16592,16400,16064,16451],0); -ELEMENTS[39535] = Fluid3D([14157,13298,13917,13953],0); -ELEMENTS[39536] = Fluid3D([4653,4695,5033,4365],0); -ELEMENTS[39537] = Fluid3D([17489,17648,17263,17633],0); -ELEMENTS[39538] = Fluid3D([7626,8326,7409,7363],0); -ELEMENTS[39539] = Fluid3D([11136,12029,11558,12433],0); -ELEMENTS[39540] = Fluid3D([14774,13992,14456,14687],0); -ELEMENTS[39541] = Fluid3D([14456,14774,14687,15273],0); -ELEMENTS[39542] = Fluid3D([14774,13992,14687,14723],0); -ELEMENTS[39543] = Fluid3D([13992,14687,14723,13932],0); -ELEMENTS[39544] = Fluid3D([14687,14723,13932,14552],0); -ELEMENTS[39545] = Fluid3D([14687,14723,14552,15273],0); -ELEMENTS[39546] = Fluid3D([14552,14687,15273,14456],0); -ELEMENTS[39547] = Fluid3D([14687,14723,15273,14774],0); -ELEMENTS[39548] = Fluid3D([14552,14687,14456,13992],0); -ELEMENTS[39549] = Fluid3D([13932,14687,14552,13992],0); -ELEMENTS[39550] = Fluid3D([14702,14708,15322,15431],0); -ELEMENTS[39551] = Fluid3D([7699,7243,6835,7372],0); -ELEMENTS[39552] = Fluid3D([15727,16273,16197,15835],0); -ELEMENTS[39553] = Fluid3D([11904,11724,12376,11293],0); -ELEMENTS[39554] = Fluid3D([6047,5436,5555,5842],0); -ELEMENTS[39555] = Fluid3D([9773,10173,9780,10817],0); -ELEMENTS[39556] = Fluid3D([8551,8117,8203,7237],0); -ELEMENTS[39557] = Fluid3D([3144,3174,2771,3248],0); -ELEMENTS[39558] = Fluid3D([14363,13747,13496,14205],0); -ELEMENTS[39559] = Fluid3D([14363,13747,14205,14657],0); -ELEMENTS[39560] = Fluid3D([14205,14363,14657,14994],0); -ELEMENTS[39561] = Fluid3D([14205,14363,14994,14150],0); -ELEMENTS[39562] = Fluid3D([14205,14363,14150,13496],0); -ELEMENTS[39563] = Fluid3D([14657,14205,14994,14531],0); -ELEMENTS[39564] = Fluid3D([14994,14205,14150,14531],0); -ELEMENTS[39565] = Fluid3D([14205,14150,14531,13846],0); -ELEMENTS[39566] = Fluid3D([14205,14150,13846,13204],0); -ELEMENTS[39567] = Fluid3D([14657,14205,14531,13846],0); -ELEMENTS[39568] = Fluid3D([14657,14205,13846,13747],0); -ELEMENTS[39569] = Fluid3D([14363,14657,14994,15049],0); -ELEMENTS[39570] = Fluid3D([14994,14363,15049,15370],0); -ELEMENTS[39571] = Fluid3D([14150,14205,13496,13204],0); -ELEMENTS[39572] = Fluid3D([15049,14994,15370,15673],0); -ELEMENTS[39573] = Fluid3D([14994,15370,15673,15739],0); -ELEMENTS[39574] = Fluid3D([15370,15049,15673,15488],0); -ELEMENTS[39575] = Fluid3D([15049,14994,15673,15739],0); -ELEMENTS[39576] = Fluid3D([16485,16767,16573,17035],0); -ELEMENTS[39577] = Fluid3D([11341,10903,11475,10553],0); -ELEMENTS[39578] = Fluid3D([10903,11475,10553,10429],0); -ELEMENTS[39579] = Fluid3D([11341,10903,10553,10399],0); -ELEMENTS[39580] = Fluid3D([10553,11341,10399,11448],0); -ELEMENTS[39581] = Fluid3D([10553,11341,11448,11475],0); -ELEMENTS[39582] = Fluid3D([11341,11448,11475,12041],0); -ELEMENTS[39583] = Fluid3D([11341,11448,12041,11982],0); -ELEMENTS[39584] = Fluid3D([11341,11448,11982,11105],0); -ELEMENTS[39585] = Fluid3D([11341,10399,11448,11105],0); -ELEMENTS[39586] = Fluid3D([11448,10553,11475,11095],0); -ELEMENTS[39587] = Fluid3D([11475,11341,12041,11590],0); -ELEMENTS[39588] = Fluid3D([11341,12041,11590,12116],0); -ELEMENTS[39589] = Fluid3D([12041,11590,12116,12578],0); -ELEMENTS[39590] = Fluid3D([11341,12041,12116,11982],0); -ELEMENTS[39591] = Fluid3D([12116,11341,11982,11020],0); -ELEMENTS[39592] = Fluid3D([12041,11590,12578,12393],0); -ELEMENTS[39593] = Fluid3D([11590,12578,12393,11707],0); -ELEMENTS[39594] = Fluid3D([12041,11590,12393,11815],0); -ELEMENTS[39595] = Fluid3D([11590,11341,12116,11020],0); -ELEMENTS[39596] = Fluid3D([12578,12041,12393,13075],0); -ELEMENTS[39597] = Fluid3D([12393,12578,13075,13024],0); -ELEMENTS[39598] = Fluid3D([12393,12578,13024,11707],0); -ELEMENTS[39599] = Fluid3D([11590,12116,12578,11551],0); -ELEMENTS[39600] = Fluid3D([10399,10553,11448,9956],0); -ELEMENTS[39601] = Fluid3D([10399,10553,9956,9572],0); -ELEMENTS[39602] = Fluid3D([12116,12041,12578,13310],0); -ELEMENTS[39603] = Fluid3D([12393,12041,11815,13075],0); -ELEMENTS[39604] = Fluid3D([9483,8739,9502,9036],0); -ELEMENTS[39605] = Fluid3D([6490,6030,6432,6679],0); -ELEMENTS[39606] = Fluid3D([6030,6432,6679,6215],0); -ELEMENTS[39607] = Fluid3D([6432,6679,6215,6468],0); -ELEMENTS[39608] = Fluid3D([6432,6679,6468,7283],0); -ELEMENTS[39609] = Fluid3D([6468,6432,7283,7312],0); -ELEMENTS[39610] = Fluid3D([6432,6679,7283,7312],0); -ELEMENTS[39611] = Fluid3D([17126,17013,16854,17277],0); -ELEMENTS[39612] = Fluid3D([12077,12059,12499,12593],0); -ELEMENTS[39613] = Fluid3D([14847,14155,14712,14247],0); -ELEMENTS[39614] = Fluid3D([15775,16272,16372,15834],0); -ELEMENTS[39615] = Fluid3D([4626,4225,4100,4172],0); -ELEMENTS[39616] = Fluid3D([4225,4100,4172,3591],0); -ELEMENTS[39617] = Fluid3D([13574,13217,13933,13028],0); -ELEMENTS[39618] = Fluid3D([7667,7658,8330,8492],0); -ELEMENTS[39619] = Fluid3D([7329,6718,6689,6664],0); -ELEMENTS[39620] = Fluid3D([9902,10391,9877,8849],0); -ELEMENTS[39621] = Fluid3D([8440,9361,8735,9201],0); -ELEMENTS[39622] = Fluid3D([6698,6647,6456,5969],0); -ELEMENTS[39623] = Fluid3D([9356,8748,8676,8621],0); -ELEMENTS[39624] = Fluid3D([16649,16208,16691,16422],0); -ELEMENTS[39625] = Fluid3D([2350,2409,2193,2550],0); -ELEMENTS[39626] = Fluid3D([8457,9319,9467,8427],0); -ELEMENTS[39627] = Fluid3D([17529,17605,17760,17861],0); -ELEMENTS[39628] = Fluid3D([17529,17605,17861,17491],0); -ELEMENTS[39629] = Fluid3D([17605,17861,17491,17807],0); -ELEMENTS[39630] = Fluid3D([17861,17491,17807,17611],0); -ELEMENTS[39631] = Fluid3D([17491,17807,17611,17562],0); -ELEMENTS[39632] = Fluid3D([17861,17491,17611,17529],0); -ELEMENTS[39633] = Fluid3D([17611,17491,17562,17347],0); -ELEMENTS[39634] = Fluid3D([17491,17611,17529,17207],0); -ELEMENTS[39635] = Fluid3D([17491,17611,17207,17347],0); -ELEMENTS[39636] = Fluid3D([12016,12122,12551,11474],0); -ELEMENTS[39637] = Fluid3D([8074,8028,7263,7795],0); -ELEMENTS[39638] = Fluid3D([8586,7723,8533,7907],0); -ELEMENTS[39639] = Fluid3D([10803,10690,11632,10770],0); -ELEMENTS[39640] = Fluid3D([10473,10859,10042,11009],0); -ELEMENTS[39641] = Fluid3D([14396,14117,14198,14945],0); -ELEMENTS[39642] = Fluid3D([18192,18124,18301,18379],0); -ELEMENTS[39643] = Fluid3D([3129,3113,3605,3237],0); -ELEMENTS[39644] = Fluid3D([4437,4622,4570,4112],0); -ELEMENTS[39645] = Fluid3D([4120,4591,4434,3847],0); -ELEMENTS[39646] = Fluid3D([15446,15888,16018,15826],0); -ELEMENTS[39647] = Fluid3D([7346,7768,8133,8036],0); -ELEMENTS[39648] = Fluid3D([7346,7768,8036,7257],0); -ELEMENTS[39649] = Fluid3D([7346,7768,7257,7123],0); -ELEMENTS[39650] = Fluid3D([7768,8036,7257,8147],0); -ELEMENTS[39651] = Fluid3D([7768,8036,8147,8758],0); -ELEMENTS[39652] = Fluid3D([7768,8036,8758,8133],0); -ELEMENTS[39653] = Fluid3D([8147,7768,8758,8493],0); -ELEMENTS[39654] = Fluid3D([7768,8758,8493,8623],0); -ELEMENTS[39655] = Fluid3D([8493,7768,8623,8272],0); -ELEMENTS[39656] = Fluid3D([8036,8147,8758,8765],0); -ELEMENTS[39657] = Fluid3D([8147,7768,8493,8027],0); -ELEMENTS[39658] = Fluid3D([8758,8493,8623,9295],0); -ELEMENTS[39659] = Fluid3D([8493,8623,9295,9257],0); -ELEMENTS[39660] = Fluid3D([8758,8493,9295,9148],0); -ELEMENTS[39661] = Fluid3D([8758,8147,8493,9148],0); -ELEMENTS[39662] = Fluid3D([8623,8493,8272,9257],0); -ELEMENTS[39663] = Fluid3D([8493,8272,9257,9148],0); -ELEMENTS[39664] = Fluid3D([8758,8147,9148,8765],0); -ELEMENTS[39665] = Fluid3D([7768,8758,8623,8133],0); -ELEMENTS[39666] = Fluid3D([13672,13173,14071,13023],0); -ELEMENTS[39667] = Fluid3D([16325,16245,16121,15728],0); -ELEMENTS[39668] = Fluid3D([6043,5703,5936,6556],0); -ELEMENTS[39669] = Fluid3D([17730,17641,17726,17407],0); -ELEMENTS[39670] = Fluid3D([17641,17726,17407,17606],0); -ELEMENTS[39671] = Fluid3D([11834,11847,12405,11278],0); -ELEMENTS[39672] = Fluid3D([5514,5131,4911,5098],0); -ELEMENTS[39673] = Fluid3D([4911,5514,5098,5395],0); -ELEMENTS[39674] = Fluid3D([5131,4911,5098,4476],0); -ELEMENTS[39675] = Fluid3D([5098,4911,5395,4634],0); -ELEMENTS[39676] = Fluid3D([5098,4911,4634,4476],0); -ELEMENTS[39677] = Fluid3D([5514,5131,5098,5515],0); -ELEMENTS[39678] = Fluid3D([5514,5098,5395,5515],0); -ELEMENTS[39679] = Fluid3D([2440,2537,2290,2527],0); -ELEMENTS[39680] = Fluid3D([10457,10714,10143,11216],0); -ELEMENTS[39681] = Fluid3D([10457,10714,11216,11336],0); -ELEMENTS[39682] = Fluid3D([14720,14343,13874,14161],0); -ELEMENTS[39683] = Fluid3D([14528,14981,14642,15396],0); -ELEMENTS[39684] = Fluid3D([10390,11129,10414,10587],0); -ELEMENTS[39685] = Fluid3D([15839,16217,16219,15735],0); -ELEMENTS[39686] = Fluid3D([16219,15839,15735,15687],0); -ELEMENTS[39687] = Fluid3D([13719,13894,13827,13097],0); -ELEMENTS[39688] = Fluid3D([13894,13827,13097,13613],0); -ELEMENTS[39689] = Fluid3D([13719,13894,13097,13369],0); -ELEMENTS[39690] = Fluid3D([13827,13719,13097,13460],0); -ELEMENTS[39691] = Fluid3D([13719,13097,13460,12988],0); -ELEMENTS[39692] = Fluid3D([13460,13719,12988,13661],0); -ELEMENTS[39693] = Fluid3D([13097,13460,12988,12625],0); -ELEMENTS[39694] = Fluid3D([13719,13097,12988,13661],0); -ELEMENTS[39695] = Fluid3D([13460,12988,12625,12614],0); -ELEMENTS[39696] = Fluid3D([12988,13097,12625,12036],0); -ELEMENTS[39697] = Fluid3D([13827,13719,13460,14557],0); -ELEMENTS[39698] = Fluid3D([13097,13460,12625,13827],0); -ELEMENTS[39699] = Fluid3D([13719,13460,14557,14143],0); -ELEMENTS[39700] = Fluid3D([13719,13460,14143,13661],0); -ELEMENTS[39701] = Fluid3D([13097,13894,13613,13453],0); -ELEMENTS[39702] = Fluid3D([13894,13097,13369,13453],0); -ELEMENTS[39703] = Fluid3D([11477,10796,10893,11947],0); -ELEMENTS[39704] = Fluid3D([13342,13890,13650,14167],0); -ELEMENTS[39705] = Fluid3D([13342,13890,14167,14386],0); -ELEMENTS[39706] = Fluid3D([13650,13342,14167,13492],0); -ELEMENTS[39707] = Fluid3D([13342,14167,13492,13722],0); -ELEMENTS[39708] = Fluid3D([13492,13342,13722,12873],0); -ELEMENTS[39709] = Fluid3D([13342,13722,12873,13533],0); -ELEMENTS[39710] = Fluid3D([14167,13492,13722,14431],0); -ELEMENTS[39711] = Fluid3D([13342,14167,13722,14386],0); -ELEMENTS[39712] = Fluid3D([13492,13342,12873,12422],0); -ELEMENTS[39713] = Fluid3D([12873,13342,13533,12605],0); -ELEMENTS[39714] = Fluid3D([13650,13342,13492,12422],0); -ELEMENTS[39715] = Fluid3D([13342,12873,12422,11795],0); -ELEMENTS[39716] = Fluid3D([14648,14210,14463,14902],0); -ELEMENTS[39717] = Fluid3D([11952,11850,12268,13149],0); -ELEMENTS[39718] = Fluid3D([12890,13122,12965,12180],0); -ELEMENTS[39719] = Fluid3D([6643,6355,6227,6969],0); -ELEMENTS[39720] = Fluid3D([12649,13246,13419,12960],0); -ELEMENTS[39721] = Fluid3D([14937,15603,15189,15182],0); -ELEMENTS[39722] = Fluid3D([15719,16113,15957,15428],0); -ELEMENTS[39723] = Fluid3D([15957,15719,15428,15274],0); -ELEMENTS[39724] = Fluid3D([17330,17050,17016,17158],0); -ELEMENTS[39725] = Fluid3D([16109,16429,16360,15831],0); -ELEMENTS[39726] = Fluid3D([13628,13648,12969,14073],0); -ELEMENTS[39727] = Fluid3D([4915,5043,5460,5498],0); -ELEMENTS[39728] = Fluid3D([5460,4915,5498,5186],0); -ELEMENTS[39729] = Fluid3D([18411,18450,18407,18561],0); -ELEMENTS[39730] = Fluid3D([17340,16982,17370,17042],0); -ELEMENTS[39731] = Fluid3D([8269,7290,7810,8053],0); -ELEMENTS[39732] = Fluid3D([7810,8269,8053,8591],0); -ELEMENTS[39733] = Fluid3D([8269,7290,8053,7651],0); -ELEMENTS[39734] = Fluid3D([8053,8269,7651,8155],0); -ELEMENTS[39735] = Fluid3D([8053,8269,8155,8446],0); -ELEMENTS[39736] = Fluid3D([8053,8269,8446,8773],0); -ELEMENTS[39737] = Fluid3D([8446,8053,8773,7954],0); -ELEMENTS[39738] = Fluid3D([8053,8269,8773,8591],0); -ELEMENTS[39739] = Fluid3D([7651,8053,8155,8446],0); -ELEMENTS[39740] = Fluid3D([8773,8446,7954,8792],0); -ELEMENTS[39741] = Fluid3D([5131,5074,5515,5709],0); -ELEMENTS[39742] = Fluid3D([5131,5074,5709,5249],0); -ELEMENTS[39743] = Fluid3D([5131,5074,5249,4819],0); -ELEMENTS[39744] = Fluid3D([5131,5074,4819,4431],0); -ELEMENTS[39745] = Fluid3D([5074,5249,4819,4431],0); -ELEMENTS[39746] = Fluid3D([5249,4819,4431,4606],0); -ELEMENTS[39747] = Fluid3D([5402,5396,5851,5002],0); -ELEMENTS[39748] = Fluid3D([16635,17103,16859,16691],0); -ELEMENTS[39749] = Fluid3D([16368,16369,16527,15909],0); -ELEMENTS[39750] = Fluid3D([13535,12783,13172,12522],0); -ELEMENTS[39751] = Fluid3D([12783,13172,12522,12161],0); -ELEMENTS[39752] = Fluid3D([13535,12783,12522,12384],0); -ELEMENTS[39753] = Fluid3D([16373,16366,15911,16464],0); -ELEMENTS[39754] = Fluid3D([7184,7493,7914,7069],0); -ELEMENTS[39755] = Fluid3D([7914,7184,7069,7450],0); -ELEMENTS[39756] = Fluid3D([7069,7914,7450,8116],0); -ELEMENTS[39757] = Fluid3D([7184,7069,7450,6405],0); -ELEMENTS[39758] = Fluid3D([18107,18092,17830,18037],0); -ELEMENTS[39759] = Fluid3D([11311,10773,10406,11552],0); -ELEMENTS[39760] = Fluid3D([6729,7375,6818,7422],0); -ELEMENTS[39761] = Fluid3D([14169,14877,14313,14491],0); -ELEMENTS[39762] = Fluid3D([8877,8649,8884,7794],0); -ELEMENTS[39763] = Fluid3D([15790,15898,15700,16398],0); -ELEMENTS[39764] = Fluid3D([2997,3168,3437,3135],0); -ELEMENTS[39765] = Fluid3D([2997,3168,3135,2832],0); -ELEMENTS[39766] = Fluid3D([3168,3135,2832,2819],0); -ELEMENTS[39767] = Fluid3D([2997,3168,2832,2870],0); -ELEMENTS[39768] = Fluid3D([3168,2832,2870,2819],0); -ELEMENTS[39769] = Fluid3D([2832,2870,2819,2581],0); -ELEMENTS[39770] = Fluid3D([2819,2832,2581,2695],0); -ELEMENTS[39771] = Fluid3D([2819,2832,2695,3135],0); -ELEMENTS[39772] = Fluid3D([2832,2581,2695,2683],0); -ELEMENTS[39773] = Fluid3D([2832,2581,2683,2742],0); -ELEMENTS[39774] = Fluid3D([2832,2581,2742,2870],0); -ELEMENTS[39775] = Fluid3D([2695,2832,2683,3135],0); -ELEMENTS[39776] = Fluid3D([2742,2832,2870,2997],0); -ELEMENTS[39777] = Fluid3D([2683,2832,2742,2997],0); -ELEMENTS[39778] = Fluid3D([2581,2683,2742,2450],0); -ELEMENTS[39779] = Fluid3D([2742,2581,2450,2340],0); -ELEMENTS[39780] = Fluid3D([2683,2832,2997,3135],0); -ELEMENTS[39781] = Fluid3D([2581,2695,2683,2322],0); -ELEMENTS[39782] = Fluid3D([2581,2683,2450,2322],0); -ELEMENTS[39783] = Fluid3D([2742,2683,2997,2718],0); -ELEMENTS[39784] = Fluid3D([2581,2819,2695,2491],0); -ELEMENTS[39785] = Fluid3D([2683,2742,2450,2718],0); -ELEMENTS[39786] = Fluid3D([3168,3437,3135,3480],0); -ELEMENTS[39787] = Fluid3D([3437,2997,3135,3198],0); -ELEMENTS[39788] = Fluid3D([2581,2742,2870,2512],0); -ELEMENTS[39789] = Fluid3D([16151,15683,15492,15825],0); -ELEMENTS[39790] = Fluid3D([16151,15683,15825,16338],0); -ELEMENTS[39791] = Fluid3D([15683,15492,15825,15213],0); -ELEMENTS[39792] = Fluid3D([15492,16151,15825,16425],0); -ELEMENTS[39793] = Fluid3D([16151,15825,16425,16198],0); -ELEMENTS[39794] = Fluid3D([15825,16151,16338,16198],0); -ELEMENTS[39795] = Fluid3D([2541,2415,2386,2728],0); -ELEMENTS[39796] = Fluid3D([2386,2541,2728,2419],0); -ELEMENTS[39797] = Fluid3D([2728,2386,2419,2408],0); -ELEMENTS[39798] = Fluid3D([2386,2419,2408,2203],0); -ELEMENTS[39799] = Fluid3D([2408,2386,2203,2415],0); -ELEMENTS[39800] = Fluid3D([2386,2419,2203,2062],0); -ELEMENTS[39801] = Fluid3D([2386,2203,2415,2249],0); -ELEMENTS[39802] = Fluid3D([2386,2203,2249,2062],0); -ELEMENTS[39803] = Fluid3D([14957,14534,14904,13810],0); -ELEMENTS[39804] = Fluid3D([3246,3319,3670,3330],0); -ELEMENTS[39805] = Fluid3D([15117,15286,15809,14875],0); -ELEMENTS[39806] = Fluid3D([6728,6912,6233,5744],0); -ELEMENTS[39807] = Fluid3D([15254,15631,15507,15910],0); -ELEMENTS[39808] = Fluid3D([11404,11867,12638,11581],0); -ELEMENTS[39809] = Fluid3D([11404,11867,11581,11224],0); -ELEMENTS[39810] = Fluid3D([11404,11867,11224,10675],0); -ELEMENTS[39811] = Fluid3D([11224,11404,10675,11581],0); -ELEMENTS[39812] = Fluid3D([17014,16900,16504,17136],0); -ELEMENTS[39813] = Fluid3D([6692,7143,7488,7351],0); -ELEMENTS[39814] = Fluid3D([12161,12501,12448,13172],0); -ELEMENTS[39815] = Fluid3D([9572,10116,9529,10211],0); -ELEMENTS[39816] = Fluid3D([9529,9572,10211,10399],0); -ELEMENTS[39817] = Fluid3D([9572,10116,10211,10429],0); -ELEMENTS[39818] = Fluid3D([13257,13009,13063,12144],0); -ELEMENTS[39819] = Fluid3D([3619,3229,3471,3817],0); -ELEMENTS[39820] = Fluid3D([17387,17350,17035,16848],0); -ELEMENTS[39821] = Fluid3D([10916,10930,10281,9570],0); -ELEMENTS[39822] = Fluid3D([16678,16611,16444,17167],0); -ELEMENTS[39823] = Fluid3D([10498,11315,10780,11839],0); -ELEMENTS[39824] = Fluid3D([6397,6411,7005,6156],0); -ELEMENTS[39825] = Fluid3D([9710,9190,8848,9780],0); -ELEMENTS[39826] = Fluid3D([12537,12383,13175,12686],0); -ELEMENTS[39827] = Fluid3D([15391,15786,15667,15999],0); -ELEMENTS[39828] = Fluid3D([2346,2594,2383,2448],0); -ELEMENTS[39829] = Fluid3D([6051,6236,6741,6468],0); -ELEMENTS[39830] = Fluid3D([16839,17045,16935,17540],0); -ELEMENTS[39831] = Fluid3D([11536,10908,11300,11211],0); -ELEMENTS[39832] = Fluid3D([10908,11300,11211,10403],0); -ELEMENTS[39833] = Fluid3D([11211,10908,10403,11256],0); -ELEMENTS[39834] = Fluid3D([16246,15842,16000,16513],0); -ELEMENTS[39835] = Fluid3D([14533,14501,14260,13410],0); -ELEMENTS[39836] = Fluid3D([11096,10825,11951,11518],0); -ELEMENTS[39837] = Fluid3D([7105,7031,7495,6531],0); -ELEMENTS[39838] = Fluid3D([4533,4928,4367,4646],0); -ELEMENTS[39839] = Fluid3D([4721,4267,4662,4424],0); -ELEMENTS[39840] = Fluid3D([10152,9437,9456,10393],0); -ELEMENTS[39841] = Fluid3D([18096,18129,18152,18410],0); -ELEMENTS[39842] = Fluid3D([17932,18117,18131,18289],0); -ELEMENTS[39843] = Fluid3D([15701,15578,16025,14997],0); -ELEMENTS[39844] = Fluid3D([8462,8536,8196,8998],0); -ELEMENTS[39845] = Fluid3D([11455,11691,11579,12574],0); -ELEMENTS[39846] = Fluid3D([10776,11561,11081,10705],0); -ELEMENTS[39847] = Fluid3D([17108,17070,17550,17135],0); -ELEMENTS[39848] = Fluid3D([5292,5542,5213,4757],0); -ELEMENTS[39849] = Fluid3D([10686,10942,10636,9905],0); -ELEMENTS[39850] = Fluid3D([17725,17903,17586,17945],0); -ELEMENTS[39851] = Fluid3D([17116,17291,16998,16801],0); -ELEMENTS[39852] = Fluid3D([14952,14455,14832,15171],0); -ELEMENTS[39853] = Fluid3D([14952,14455,15171,14655],0); -ELEMENTS[39854] = Fluid3D([15171,14952,14655,15352],0); -ELEMENTS[39855] = Fluid3D([15438,14804,15016,15186],0); -ELEMENTS[39856] = Fluid3D([9015,9680,9070,9009],0); -ELEMENTS[39857] = Fluid3D([3605,3640,3184,3295],0); -ELEMENTS[39858] = Fluid3D([2234,2372,2269,2135],0); -ELEMENTS[39859] = Fluid3D([13891,14102,13249,13917],0); -ELEMENTS[39860] = Fluid3D([13891,14102,13917,14468],0); -ELEMENTS[39861] = Fluid3D([12545,13266,12956,12350],0); -ELEMENTS[39862] = Fluid3D([5493,5269,5893,5348],0); -ELEMENTS[39863] = Fluid3D([5493,5269,5348,4691],0); -ELEMENTS[39864] = Fluid3D([5893,5493,5348,5978],0); -ELEMENTS[39865] = Fluid3D([5493,5348,5978,5719],0); -ELEMENTS[39866] = Fluid3D([3423,3140,3576,2989],0); -ELEMENTS[39867] = Fluid3D([4109,4525,4602,4568],0); -ELEMENTS[39868] = Fluid3D([9590,9372,8776,8492],0); -ELEMENTS[39869] = Fluid3D([8388,8455,9265,8820],0); -ELEMENTS[39870] = Fluid3D([14879,14063,14445,14422],0); -ELEMENTS[39871] = Fluid3D([6303,6779,5872,6060],0); -ELEMENTS[39872] = Fluid3D([5872,6303,6060,5572],0); -ELEMENTS[39873] = Fluid3D([6060,5872,5572,5494],0); -ELEMENTS[39874] = Fluid3D([6779,5872,6060,6002],0); -ELEMENTS[39875] = Fluid3D([5872,6060,6002,5494],0); -ELEMENTS[39876] = Fluid3D([6303,6779,6060,6401],0); -ELEMENTS[39877] = Fluid3D([6303,6060,5572,5963],0); -ELEMENTS[39878] = Fluid3D([6303,6060,5963,6401],0); -ELEMENTS[39879] = Fluid3D([6060,5963,6401,5979],0); -ELEMENTS[39880] = Fluid3D([6060,5572,5963,5494],0); -ELEMENTS[39881] = Fluid3D([5963,6303,6401,6374],0); -ELEMENTS[39882] = Fluid3D([6401,5963,6374,6517],0); -ELEMENTS[39883] = Fluid3D([5963,6303,6374,5715],0); -ELEMENTS[39884] = Fluid3D([6374,5963,5715,5973],0); -ELEMENTS[39885] = Fluid3D([6374,5963,5973,6517],0); -ELEMENTS[39886] = Fluid3D([5973,6374,6517,6363],0); -ELEMENTS[39887] = Fluid3D([5963,5715,5973,5738],0); -ELEMENTS[39888] = Fluid3D([5973,5963,5738,6517],0); -ELEMENTS[39889] = Fluid3D([5738,5973,6517,6027],0); -ELEMENTS[39890] = Fluid3D([5738,5973,6027,5710],0); -ELEMENTS[39891] = Fluid3D([5738,5973,5710,5385],0); -ELEMENTS[39892] = Fluid3D([5738,5973,5385,5715],0); -ELEMENTS[39893] = Fluid3D([5973,5710,5385,6363],0); -ELEMENTS[39894] = Fluid3D([5973,5385,5715,6363],0); -ELEMENTS[39895] = Fluid3D([5963,6401,5979,5738],0); -ELEMENTS[39896] = Fluid3D([6517,5973,6363,6027],0); -ELEMENTS[39897] = Fluid3D([5963,6401,5738,6517],0); -ELEMENTS[39898] = Fluid3D([5973,6027,5710,6363],0); -ELEMENTS[39899] = Fluid3D([6146,5657,5922,5299],0); -ELEMENTS[39900] = Fluid3D([15635,16029,15478,16251],0); -ELEMENTS[39901] = Fluid3D([11016,10184,11108,10714],0); -ELEMENTS[39902] = Fluid3D([16806,16925,16441,16706],0); -ELEMENTS[39903] = Fluid3D([11255,10769,11731,11579],0); -ELEMENTS[39904] = Fluid3D([14489,13957,13609,14433],0); -ELEMENTS[39905] = Fluid3D([11976,12565,12038,13106],0); -ELEMENTS[39906] = Fluid3D([8641,8936,9569,9505],0); -ELEMENTS[39907] = Fluid3D([13053,12510,12792,13428],0); -ELEMENTS[39908] = Fluid3D([8912,8657,9684,9393],0); -ELEMENTS[39909] = Fluid3D([8912,8657,9393,9165],0); -ELEMENTS[39910] = Fluid3D([13045,12105,12802,12378],0); -ELEMENTS[39911] = Fluid3D([13080,13967,13315,13250],0); -ELEMENTS[39912] = Fluid3D([13951,13765,13092,13274],0); -ELEMENTS[39913] = Fluid3D([5686,5481,5730,5176],0); -ELEMENTS[39914] = Fluid3D([13585,13085,13758,12468],0); -ELEMENTS[39915] = Fluid3D([4378,4117,4637,4132],0); -ELEMENTS[39916] = Fluid3D([4637,4378,4132,4324],0); -ELEMENTS[39917] = Fluid3D([16209,15813,16077,15559],0); -ELEMENTS[39918] = Fluid3D([8062,8228,9062,7545],0); -ELEMENTS[39919] = Fluid3D([10433,10435,9391,10174],0); -ELEMENTS[39920] = Fluid3D([13488,14302,13703,13503],0); -ELEMENTS[39921] = Fluid3D([12374,11905,12430,11749],0); -ELEMENTS[39922] = Fluid3D([12374,11905,11749,11869],0); -ELEMENTS[39923] = Fluid3D([11749,12374,11869,12748],0); -ELEMENTS[39924] = Fluid3D([11869,11749,12748,11453],0); -ELEMENTS[39925] = Fluid3D([12374,11869,12748,12974],0); -ELEMENTS[39926] = Fluid3D([11869,11749,11453,10888],0); -ELEMENTS[39927] = Fluid3D([11869,11749,10888,11417],0); -ELEMENTS[39928] = Fluid3D([11749,12374,12748,12430],0); -ELEMENTS[39929] = Fluid3D([11905,12430,11749,11602],0); -ELEMENTS[39930] = Fluid3D([11749,11905,11602,10888],0); -ELEMENTS[39931] = Fluid3D([11602,11749,10888,11453],0); -ELEMENTS[39932] = Fluid3D([11602,11749,11453,12319],0); -ELEMENTS[39933] = Fluid3D([12430,11749,11602,12319],0); -ELEMENTS[39934] = Fluid3D([10888,11602,11453,10441],0); -ELEMENTS[39935] = Fluid3D([4612,4171,4175,4441],0); -ELEMENTS[39936] = Fluid3D([15387,15401,15163,15759],0); -ELEMENTS[39937] = Fluid3D([15387,15401,15759,16007],0); -ELEMENTS[39938] = Fluid3D([15163,15387,15759,15847],0); -ELEMENTS[39939] = Fluid3D([15387,15759,15847,15517],0); -ELEMENTS[39940] = Fluid3D([15387,15759,15517,16007],0); -ELEMENTS[39941] = Fluid3D([16866,16565,16349,16546],0); -ELEMENTS[39942] = Fluid3D([5582,5690,6174,5398],0); -ELEMENTS[39943] = Fluid3D([17090,16912,17366,17403],0); -ELEMENTS[39944] = Fluid3D([17366,17090,17403,17445],0); -ELEMENTS[39945] = Fluid3D([17090,17403,17445,17298],0); -ELEMENTS[39946] = Fluid3D([17366,17090,17445,17143],0); -ELEMENTS[39947] = Fluid3D([17090,17445,17143,17298],0); -ELEMENTS[39948] = Fluid3D([17445,17143,17298,17286],0); -ELEMENTS[39949] = Fluid3D([17445,17143,17286,17366],0); -ELEMENTS[39950] = Fluid3D([17143,17298,17286,16944],0); -ELEMENTS[39951] = Fluid3D([7897,8495,8613,9034],0); -ELEMENTS[39952] = Fluid3D([8962,9181,8928,9863],0); -ELEMENTS[39953] = Fluid3D([9761,9135,9114,9032],0); -ELEMENTS[39954] = Fluid3D([9135,9114,9032,8509],0); -ELEMENTS[39955] = Fluid3D([9032,9135,8509,9014],0); -ELEMENTS[39956] = Fluid3D([8509,9032,9014,8905],0); -ELEMENTS[39957] = Fluid3D([8509,9032,8905,9298],0); -ELEMENTS[39958] = Fluid3D([8509,9032,9298,9114],0); -ELEMENTS[39959] = Fluid3D([9032,8905,9298,9761],0); -ELEMENTS[39960] = Fluid3D([9032,9298,9114,9761],0); -ELEMENTS[39961] = Fluid3D([9032,9135,9014,9761],0); -ELEMENTS[39962] = Fluid3D([9014,9032,9761,8905],0); -ELEMENTS[39963] = Fluid3D([16000,15909,15836,15399],0); -ELEMENTS[39964] = Fluid3D([15909,15836,15399,15244],0); -ELEMENTS[39965] = Fluid3D([12501,11349,12448,12000],0); -ELEMENTS[39966] = Fluid3D([12493,11718,11676,11896],0); -ELEMENTS[39967] = Fluid3D([18599,18615,18603,18510],0); -ELEMENTS[39968] = Fluid3D([8666,8622,8300,9228],0); -ELEMENTS[39969] = Fluid3D([8300,8666,9228,8809],0); -ELEMENTS[39970] = Fluid3D([8666,8622,9228,9328],0); -ELEMENTS[39971] = Fluid3D([13138,13780,13193,13715],0); -ELEMENTS[39972] = Fluid3D([16270,16020,16197,16335],0); -ELEMENTS[39973] = Fluid3D([16020,16197,16335,15692],0); -ELEMENTS[39974] = Fluid3D([16197,16270,16335,16802],0); -ELEMENTS[39975] = Fluid3D([16335,16197,16802,16779],0); -ELEMENTS[39976] = Fluid3D([16270,16020,16335,16407],0); -ELEMENTS[39977] = Fluid3D([8210,8345,9110,8306],0); -ELEMENTS[39978] = Fluid3D([16641,17123,16857,16717],0); -ELEMENTS[39979] = Fluid3D([4190,4485,4731,4173],0); -ELEMENTS[39980] = Fluid3D([17375,17028,17050,17285],0); -ELEMENTS[39981] = Fluid3D([17375,17028,17285,17222],0); -ELEMENTS[39982] = Fluid3D([17375,17028,17222,16897],0); -ELEMENTS[39983] = Fluid3D([17028,17050,17285,17219],0); -ELEMENTS[39984] = Fluid3D([15867,15463,15691,15234],0); -ELEMENTS[39985] = Fluid3D([5516,5465,5429,5120],0); -ELEMENTS[39986] = Fluid3D([5516,5465,5120,5316],0); -ELEMENTS[39987] = Fluid3D([5465,5120,5316,5615],0); -ELEMENTS[39988] = Fluid3D([5465,5429,5120,4907],0); -ELEMENTS[39989] = Fluid3D([7995,8918,8415,8302],0); -ELEMENTS[39990] = Fluid3D([6438,5879,5816,6346],0); -ELEMENTS[39991] = Fluid3D([6720,7679,7494,7211],0); -ELEMENTS[39992] = Fluid3D([15758,16009,16304,16531],0); -ELEMENTS[39993] = Fluid3D([4135,4265,3905,4053],0); -ELEMENTS[39994] = Fluid3D([6602,7351,7306,7086],0); -ELEMENTS[39995] = Fluid3D([7306,6602,7086,6315],0); -ELEMENTS[39996] = Fluid3D([6602,7351,7086,6462],0); -ELEMENTS[39997] = Fluid3D([15806,15134,15339,15366],0); -ELEMENTS[39998] = Fluid3D([15134,15339,15366,14559],0); -ELEMENTS[39999] = Fluid3D([15339,15806,15366,16213],0); -ELEMENTS[40000] = Fluid3D([15806,15134,15366,15436],0); -ELEMENTS[40001] = Fluid3D([10463,11419,10985,11775],0); -ELEMENTS[40002] = Fluid3D([18216,18133,18018,18195],0); -ELEMENTS[40003] = Fluid3D([18133,18018,18195,17895],0); -ELEMENTS[40004] = Fluid3D([18216,18133,18195,18400],0); -ELEMENTS[40005] = Fluid3D([8589,7820,8164,7655],0); -ELEMENTS[40006] = Fluid3D([13020,13392,13750,13749],0); -ELEMENTS[40007] = Fluid3D([11620,11887,11393,10800],0); -ELEMENTS[40008] = Fluid3D([10364,9925,9969,8979],0); -ELEMENTS[40009] = Fluid3D([14946,15258,14784,14575],0); -ELEMENTS[40010] = Fluid3D([17102,17356,17135,17665],0); -ELEMENTS[40011] = Fluid3D([8292,8312,7624,8199],0); -ELEMENTS[40012] = Fluid3D([8292,8312,8199,8963],0); -ELEMENTS[40013] = Fluid3D([8312,8199,8963,8861],0); -ELEMENTS[40014] = Fluid3D([7624,8292,8199,8464],0); -ELEMENTS[40015] = Fluid3D([7624,8292,8464,7861],0); -ELEMENTS[40016] = Fluid3D([8199,8292,8963,8464],0); -ELEMENTS[40017] = Fluid3D([8199,8963,8861,9099],0); -ELEMENTS[40018] = Fluid3D([8199,8963,9099,8464],0); -ELEMENTS[40019] = Fluid3D([8963,8861,9099,9833],0); -ELEMENTS[40020] = Fluid3D([9099,8963,9833,9395],0); -ELEMENTS[40021] = Fluid3D([9099,8963,9395,8464],0); -ELEMENTS[40022] = Fluid3D([8963,9833,9395,9819],0); -ELEMENTS[40023] = Fluid3D([9833,9099,9395,10031],0); -ELEMENTS[40024] = Fluid3D([8963,9395,8464,8292],0); -ELEMENTS[40025] = Fluid3D([9833,9099,10031,9777],0); -ELEMENTS[40026] = Fluid3D([9833,9099,9777,8861],0); -ELEMENTS[40027] = Fluid3D([7624,8292,7861,8105],0); -ELEMENTS[40028] = Fluid3D([9395,9099,8464,9367],0); -ELEMENTS[40029] = Fluid3D([9395,9099,9367,10031],0); -ELEMENTS[40030] = Fluid3D([9395,8464,8292,9230],0); -ELEMENTS[40031] = Fluid3D([6659,6271,6749,7164],0); -ELEMENTS[40032] = Fluid3D([7067,7848,7574,7591],0); -ELEMENTS[40033] = Fluid3D([16805,16188,16485,16355],0); -ELEMENTS[40034] = Fluid3D([13014,13888,13315,13784],0); -ELEMENTS[40035] = Fluid3D([3550,3343,3787,3523],0); -ELEMENTS[40036] = Fluid3D([18348,18355,18158,18409],0); -ELEMENTS[40037] = Fluid3D([16935,16755,16957,17254],0); -ELEMENTS[40038] = Fluid3D([12128,11379,11111,11044],0); -ELEMENTS[40039] = Fluid3D([5077,4548,5004,4968],0); -ELEMENTS[40040] = Fluid3D([12895,12593,12499,12059],0); -ELEMENTS[40041] = Fluid3D([12499,12895,12059,12624],0); -ELEMENTS[40042] = Fluid3D([12895,12059,12624,12568],0); -ELEMENTS[40043] = Fluid3D([12499,12895,12624,13695],0); -ELEMENTS[40044] = Fluid3D([12895,12059,12568,12856],0); -ELEMENTS[40045] = Fluid3D([13698,13473,14251,13612],0); -ELEMENTS[40046] = Fluid3D([3373,3712,3447,3641],0); -ELEMENTS[40047] = Fluid3D([3373,3712,3641,3974],0); -ELEMENTS[40048] = Fluid3D([3712,3641,3974,3977],0); -ELEMENTS[40049] = Fluid3D([3373,3712,3974,3700],0); -ELEMENTS[40050] = Fluid3D([3712,3974,3700,3586],0); -ELEMENTS[40051] = Fluid3D([3712,3974,3586,4116],0); -ELEMENTS[40052] = Fluid3D([3712,3974,4116,4214],0); -ELEMENTS[40053] = Fluid3D([3712,3974,4214,4259],0); -ELEMENTS[40054] = Fluid3D([3712,3447,3641,3880],0); -ELEMENTS[40055] = Fluid3D([3447,3373,3641,3138],0); -ELEMENTS[40056] = Fluid3D([3641,3974,3977,3868],0); -ELEMENTS[40057] = Fluid3D([3641,3974,3868,3373],0); -ELEMENTS[40058] = Fluid3D([6299,6372,6066,6957],0); -ELEMENTS[40059] = Fluid3D([11242,10678,10659,10316],0); -ELEMENTS[40060] = Fluid3D([6773,7579,6951,6636],0); -ELEMENTS[40061] = Fluid3D([12589,12619,12560,11525],0); -ELEMENTS[40062] = Fluid3D([14043,13196,13265,13584],0); -ELEMENTS[40063] = Fluid3D([14868,15269,15638,15474],0); -ELEMENTS[40064] = Fluid3D([8998,8823,9682,9788],0); -ELEMENTS[40065] = Fluid3D([6741,6647,7487,6878],0); -ELEMENTS[40066] = Fluid3D([1897,1961,1893,1785],0); -ELEMENTS[40067] = Fluid3D([1893,1897,1785,1989],0); -ELEMENTS[40068] = Fluid3D([14515,14126,14257,13547],0); -ELEMENTS[40069] = Fluid3D([10705,11789,11757,11542],0); -ELEMENTS[40070] = Fluid3D([9115,8628,8966,9514],0); -ELEMENTS[40071] = Fluid3D([13591,13463,13003,12875],0); -ELEMENTS[40072] = Fluid3D([10580,11038,9993,10368],0); -ELEMENTS[40073] = Fluid3D([7907,8800,8198,8533],0); -ELEMENTS[40074] = Fluid3D([8187,8996,9070,8169],0); -ELEMENTS[40075] = Fluid3D([14891,14182,14621,15230],0); -ELEMENTS[40076] = Fluid3D([3772,4034,4380,4003],0); -ELEMENTS[40077] = Fluid3D([16030,16428,15806,16213],0); -ELEMENTS[40078] = Fluid3D([2467,2557,2716,2783],0); -ELEMENTS[40079] = Fluid3D([3875,3576,3458,3958],0); -ELEMENTS[40080] = Fluid3D([15155,14957,14383,14645],0); -ELEMENTS[40081] = Fluid3D([5187,4621,4993,4791],0); -ELEMENTS[40082] = Fluid3D([10686,11046,11552,10406],0); -ELEMENTS[40083] = Fluid3D([10148,11201,10475,11382],0); -ELEMENTS[40084] = Fluid3D([15200,14896,14643,15435],0); -ELEMENTS[40085] = Fluid3D([7227,7791,6912,6935],0); -ELEMENTS[40086] = Fluid3D([13446,13329,13418,14229],0); -ELEMENTS[40087] = Fluid3D([16255,16627,16601,16993],0); -ELEMENTS[40088] = Fluid3D([12054,11095,11899,12015],0); -ELEMENTS[40089] = Fluid3D([12054,11095,12015,11570],0); -ELEMENTS[40090] = Fluid3D([12015,12054,11570,12549],0); -ELEMENTS[40091] = Fluid3D([11899,12054,12015,12831],0); -ELEMENTS[40092] = Fluid3D([10596,11336,10457,11118],0); -ELEMENTS[40093] = Fluid3D([2734,2811,3080,3065],0); -ELEMENTS[40094] = Fluid3D([12310,11926,11796,10926],0); -ELEMENTS[40095] = Fluid3D([16337,16432,16317,16654],0); -ELEMENTS[40096] = Fluid3D([16317,16337,16654,16140],0); -ELEMENTS[40097] = Fluid3D([18014,18088,18282,18143],0); -ELEMENTS[40098] = Fluid3D([12822,12413,12623,12056],0); -ELEMENTS[40099] = Fluid3D([8252,8908,9132,8592],0); -ELEMENTS[40100] = Fluid3D([8252,8908,8592,7852],0); -ELEMENTS[40101] = Fluid3D([8592,8252,7852,9132],0); -ELEMENTS[40102] = Fluid3D([5065,4939,4477,4804],0); -ELEMENTS[40103] = Fluid3D([7582,7539,8151,6938],0); -ELEMENTS[40104] = Fluid3D([7582,7539,6938,6539],0); -ELEMENTS[40105] = Fluid3D([6938,7582,6539,7026],0); -ELEMENTS[40106] = Fluid3D([8151,7582,6938,7730],0); -ELEMENTS[40107] = Fluid3D([6938,7582,7026,6413],0); -ELEMENTS[40108] = Fluid3D([12510,11821,12610,12806],0); -ELEMENTS[40109] = Fluid3D([12642,13446,13418,13479],0); -ELEMENTS[40110] = Fluid3D([13446,13418,13479,14229],0); -ELEMENTS[40111] = Fluid3D([12659,12180,12890,12126],0); -ELEMENTS[40112] = Fluid3D([12650,12127,11524,12582],0); -ELEMENTS[40113] = Fluid3D([4620,4958,5049,4596],0); -ELEMENTS[40114] = Fluid3D([17450,17184,17397,17660],0); -ELEMENTS[40115] = Fluid3D([11007,10818,11208,10325],0); -ELEMENTS[40116] = Fluid3D([16519,16625,16913,17196],0); -ELEMENTS[40117] = Fluid3D([12771,12372,13306,12303],0); -ELEMENTS[40118] = Fluid3D([14940,15279,15271,15661],0); -ELEMENTS[40119] = Fluid3D([14940,15279,15661,15266],0); -ELEMENTS[40120] = Fluid3D([15279,15271,15661,16042],0); -ELEMENTS[40121] = Fluid3D([15661,14940,15266,15335],0); -ELEMENTS[40122] = Fluid3D([14940,15266,15335,14911],0); -ELEMENTS[40123] = Fluid3D([15661,14940,15335,15271],0); -ELEMENTS[40124] = Fluid3D([13644,14135,13844,12960],0); -ELEMENTS[40125] = Fluid3D([14025,14316,14355,14764],0); -ELEMENTS[40126] = Fluid3D([4794,4612,5097,5099],0); -ELEMENTS[40127] = Fluid3D([3910,3569,3862,4175],0); -ELEMENTS[40128] = Fluid3D([3569,3862,4175,3777],0); -ELEMENTS[40129] = Fluid3D([3862,4175,3777,4171],0); -ELEMENTS[40130] = Fluid3D([5092,5456,5644,5361],0); -ELEMENTS[40131] = Fluid3D([14219,13708,14416,14192],0); -ELEMENTS[40132] = Fluid3D([18578,18608,18518,18614],0); -ELEMENTS[40133] = Fluid3D([18518,18578,18614,18643],0); -ELEMENTS[40134] = Fluid3D([18578,18608,18614,18643],0); -ELEMENTS[40135] = Fluid3D([7852,7341,8245,8270],0); -ELEMENTS[40136] = Fluid3D([15676,15956,15396,16126],0); -ELEMENTS[40137] = Fluid3D([9181,9555,9863,10192],0); -ELEMENTS[40138] = Fluid3D([15304,14915,14678,15259],0); -ELEMENTS[40139] = Fluid3D([17354,17273,17591,17638],0); -ELEMENTS[40140] = Fluid3D([11765,11559,12076,10454],0); -ELEMENTS[40141] = Fluid3D([12029,12007,12364,13011],0); -ELEMENTS[40142] = Fluid3D([7921,8635,7842,7815],0); -ELEMENTS[40143] = Fluid3D([9714,8978,9853,9677],0); -ELEMENTS[40144] = Fluid3D([13673,14269,13472,13942],0); -ELEMENTS[40145] = Fluid3D([9219,9153,10096,9885],0); -ELEMENTS[40146] = Fluid3D([16095,16371,15787,15570],0); -ELEMENTS[40147] = Fluid3D([2842,2535,2762,2872],0); -ELEMENTS[40148] = Fluid3D([11630,12263,11966,11457],0); -ELEMENTS[40149] = Fluid3D([8633,7732,8331,7716],0); -ELEMENTS[40150] = Fluid3D([8869,8675,8614,10020],0); -ELEMENTS[40151] = Fluid3D([4531,4857,4241,4775],0); -ELEMENTS[40152] = Fluid3D([15758,15045,15251,15628],0); -ELEMENTS[40153] = Fluid3D([5401,5206,5179,4700],0); -ELEMENTS[40154] = Fluid3D([11105,11834,11278,10552],0); -ELEMENTS[40155] = Fluid3D([16504,16576,16192,16836],0); -ELEMENTS[40156] = Fluid3D([9169,8672,8789,7826],0); -ELEMENTS[40157] = Fluid3D([13741,13387,13947,12880],0); -ELEMENTS[40158] = Fluid3D([12044,12815,12866,12875],0); -ELEMENTS[40159] = Fluid3D([2588,2639,2440,2338],0); -ELEMENTS[40160] = Fluid3D([16074,16221,15626,15630],0); -ELEMENTS[40161] = Fluid3D([12382,13264,12737,13177],0); -ELEMENTS[40162] = Fluid3D([8137,8431,8160,7233],0); -ELEMENTS[40163] = Fluid3D([11390,12177,11365,11405],0); -ELEMENTS[40164] = Fluid3D([8492,8795,7992,7559],0); -ELEMENTS[40165] = Fluid3D([8795,7992,7559,8250],0); -ELEMENTS[40166] = Fluid3D([7992,7559,8250,7448],0); -ELEMENTS[40167] = Fluid3D([7992,7559,7448,7005],0); -ELEMENTS[40168] = Fluid3D([7448,7992,7005,7618],0); -ELEMENTS[40169] = Fluid3D([7005,7448,7618,6664],0); -ELEMENTS[40170] = Fluid3D([7559,7448,7005,7329],0); -ELEMENTS[40171] = Fluid3D([7448,7992,7618,8250],0); -ELEMENTS[40172] = Fluid3D([7992,8492,7559,7972],0); -ELEMENTS[40173] = Fluid3D([7559,7992,7972,7005],0); -ELEMENTS[40174] = Fluid3D([7856,6952,7181,7665],0); -ELEMENTS[40175] = Fluid3D([11409,11894,11952,10778],0); -ELEMENTS[40176] = Fluid3D([14811,15145,14421,14866],0); -ELEMENTS[40177] = Fluid3D([14811,15145,14866,15616],0); -ELEMENTS[40178] = Fluid3D([14421,14811,14866,13997],0); -ELEMENTS[40179] = Fluid3D([14811,14866,13997,14916],0); -ELEMENTS[40180] = Fluid3D([14811,14866,14916,15616],0); -ELEMENTS[40181] = Fluid3D([15240,15786,15726,15849],0); -ELEMENTS[40182] = Fluid3D([2778,2700,2503,2681],0); -ELEMENTS[40183] = Fluid3D([14141,14850,14185,14195],0); -ELEMENTS[40184] = Fluid3D([14185,14141,14195,13027],0); -ELEMENTS[40185] = Fluid3D([14850,14185,14195,14722],0); -ELEMENTS[40186] = Fluid3D([14185,14195,14722,14157],0); -ELEMENTS[40187] = Fluid3D([14195,14722,14157,14163],0); -ELEMENTS[40188] = Fluid3D([14195,14722,14163,14613],0); -ELEMENTS[40189] = Fluid3D([14185,14195,14157,13484],0); -ELEMENTS[40190] = Fluid3D([5839,6215,6468,6432],0); -ELEMENTS[40191] = Fluid3D([11652,11944,12688,12672],0); -ELEMENTS[40192] = Fluid3D([11944,12688,12672,12655],0); -ELEMENTS[40193] = Fluid3D([12672,11944,12655,11891],0); -ELEMENTS[40194] = Fluid3D([12688,12672,12655,13746],0); -ELEMENTS[40195] = Fluid3D([12655,12672,11891,12156],0); -ELEMENTS[40196] = Fluid3D([12950,12511,12541,13580],0); -ELEMENTS[40197] = Fluid3D([14600,14915,14448,15141],0); -ELEMENTS[40198] = Fluid3D([16707,16109,16360,16189],0); -ELEMENTS[40199] = Fluid3D([9506,9771,9140,10494],0); -ELEMENTS[40200] = Fluid3D([4176,4407,4556,4103],0); -ELEMENTS[40201] = Fluid3D([11616,10854,11514,11231],0); -ELEMENTS[40202] = Fluid3D([18278,18230,18314,18012],0); -ELEMENTS[40203] = Fluid3D([9607,8590,8849,8634],0); -ELEMENTS[40204] = Fluid3D([8590,8849,8634,8065],0); -ELEMENTS[40205] = Fluid3D([9607,8590,8634,9381],0); -ELEMENTS[40206] = Fluid3D([14565,14278,15082,14171],0); -ELEMENTS[40207] = Fluid3D([6792,6496,7308,6329],0); -ELEMENTS[40208] = Fluid3D([6678,7558,6790,6924],0); -ELEMENTS[40209] = Fluid3D([17373,17565,17868,17613],0); -ELEMENTS[40210] = Fluid3D([17373,17565,17613,17060],0); -ELEMENTS[40211] = Fluid3D([17868,17373,17613,17843],0); -ELEMENTS[40212] = Fluid3D([17373,17613,17843,17692],0); -ELEMENTS[40213] = Fluid3D([10658,9755,10696,10178],0); -ELEMENTS[40214] = Fluid3D([11351,11428,10456,11509],0); -ELEMENTS[40215] = Fluid3D([7122,6348,6819,6467],0); -ELEMENTS[40216] = Fluid3D([13656,13641,12817,13489],0); -ELEMENTS[40217] = Fluid3D([10281,9287,9570,9950],0); -ELEMENTS[40218] = Fluid3D([6619,7443,7446,7326],0); -ELEMENTS[40219] = Fluid3D([7443,7446,7326,8257],0); -ELEMENTS[40220] = Fluid3D([6619,7443,7326,6921],0); -ELEMENTS[40221] = Fluid3D([15545,15553,15354,16122],0); -ELEMENTS[40222] = Fluid3D([3247,3018,3423,3196],0); -ELEMENTS[40223] = Fluid3D([3018,3423,3196,2989],0); -ELEMENTS[40224] = Fluid3D([3196,3018,2989,3024],0); -ELEMENTS[40225] = Fluid3D([2989,3196,3024,3305],0); -ELEMENTS[40226] = Fluid3D([2989,3196,3305,3271],0); -ELEMENTS[40227] = Fluid3D([3196,3024,3305,3438],0); -ELEMENTS[40228] = Fluid3D([3305,3196,3438,3779],0); -ELEMENTS[40229] = Fluid3D([3196,3024,3438,3247],0); -ELEMENTS[40230] = Fluid3D([3438,3196,3247,3423],0); -ELEMENTS[40231] = Fluid3D([3024,3438,3247,3075],0); -ELEMENTS[40232] = Fluid3D([3196,3024,3247,3018],0); -ELEMENTS[40233] = Fluid3D([2989,3196,3271,3576],0); -ELEMENTS[40234] = Fluid3D([6874,6177,6224,6137],0); -ELEMENTS[40235] = Fluid3D([12994,13295,13841,13269],0); -ELEMENTS[40236] = Fluid3D([12994,13295,13269,12677],0); -ELEMENTS[40237] = Fluid3D([13295,13269,12677,12261],0); -ELEMENTS[40238] = Fluid3D([12994,13295,12677,12325],0); -ELEMENTS[40239] = Fluid3D([13269,12994,12677,12356],0); -ELEMENTS[40240] = Fluid3D([12677,13269,12356,12261],0); -ELEMENTS[40241] = Fluid3D([13295,13841,13269,14085],0); -ELEMENTS[40242] = Fluid3D([12356,12677,12261,12325],0); -ELEMENTS[40243] = Fluid3D([12677,12261,12325,12224],0); -ELEMENTS[40244] = Fluid3D([12356,12677,12325,12994],0); -ELEMENTS[40245] = Fluid3D([6270,6269,7043,6457],0); -ELEMENTS[40246] = Fluid3D([7320,7628,7210,6789],0); -ELEMENTS[40247] = Fluid3D([7320,7628,6789,6949],0); -ELEMENTS[40248] = Fluid3D([7210,7320,6789,6676],0); -ELEMENTS[40249] = Fluid3D([9374,9665,10084,9174],0); -ELEMENTS[40250] = Fluid3D([4525,4196,4266,4500],0); -ELEMENTS[40251] = Fluid3D([7690,7376,6696,7192],0); -ELEMENTS[40252] = Fluid3D([11423,10559,11130,11447],0); -ELEMENTS[40253] = Fluid3D([16157,16557,16655,16348],0); -ELEMENTS[40254] = Fluid3D([6157,6219,5880,5623],0); -ELEMENTS[40255] = Fluid3D([6219,5880,5623,5659],0); -ELEMENTS[40256] = Fluid3D([6219,5880,5659,6068],0); -ELEMENTS[40257] = Fluid3D([5880,5623,5659,5143],0); -ELEMENTS[40258] = Fluid3D([5623,6219,5659,5726],0); -ELEMENTS[40259] = Fluid3D([5880,6157,5623,5713],0); -ELEMENTS[40260] = Fluid3D([6157,6219,5623,5743],0); -ELEMENTS[40261] = Fluid3D([5623,6157,5743,5713],0); -ELEMENTS[40262] = Fluid3D([2420,2167,2283,2261],0); -ELEMENTS[40263] = Fluid3D([8739,8384,9036,8833],0); -ELEMENTS[40264] = Fluid3D([8384,9036,8833,8604],0); -ELEMENTS[40265] = Fluid3D([8739,8384,8833,8154],0); -ELEMENTS[40266] = Fluid3D([8384,8833,8154,8604],0); -ELEMENTS[40267] = Fluid3D([8384,9036,8604,8491],0); -ELEMENTS[40268] = Fluid3D([12730,13040,12732,13707],0); -ELEMENTS[40269] = Fluid3D([17478,17576,17454,17120],0); -ELEMENTS[40270] = Fluid3D([7795,7317,7263,6762],0); -ELEMENTS[40271] = Fluid3D([13610,13592,12777,13718],0); -ELEMENTS[40272] = Fluid3D([13479,14115,14072,14229],0); -ELEMENTS[40273] = Fluid3D([7715,8260,8069,7555],0); -ELEMENTS[40274] = Fluid3D([7715,8260,7555,7785],0); -ELEMENTS[40275] = Fluid3D([8069,7715,7555,7041],0); -ELEMENTS[40276] = Fluid3D([7715,7555,7041,6985],0); -ELEMENTS[40277] = Fluid3D([7715,7555,6985,7785],0); -ELEMENTS[40278] = Fluid3D([12640,12646,12923,11954],0); -ELEMENTS[40279] = Fluid3D([11852,12683,12518,11861],0); -ELEMENTS[40280] = Fluid3D([11158,11030,10605,11921],0); -ELEMENTS[40281] = Fluid3D([14919,14466,14607,15382],0); -ELEMENTS[40282] = Fluid3D([3141,2963,3203,3485],0); -ELEMENTS[40283] = Fluid3D([17012,16748,16618,16562],0); -ELEMENTS[40284] = Fluid3D([16748,16618,16562,16264],0); -ELEMENTS[40285] = Fluid3D([16562,16748,16264,16699],0); -ELEMENTS[40286] = Fluid3D([16618,16562,16264,16360],0); -ELEMENTS[40287] = Fluid3D([16618,16562,16360,17012],0); -ELEMENTS[40288] = Fluid3D([17012,16748,16562,17058],0); -ELEMENTS[40289] = Fluid3D([17207,16807,17247,17171],0); -ELEMENTS[40290] = Fluid3D([7368,7815,8170,8396],0); -ELEMENTS[40291] = Fluid3D([9782,8693,9442,9492],0); -ELEMENTS[40292] = Fluid3D([9442,9782,9492,10435],0); -ELEMENTS[40293] = Fluid3D([9782,9492,10435,9391],0); -ELEMENTS[40294] = Fluid3D([9492,10435,9391,9676],0); -ELEMENTS[40295] = Fluid3D([9391,9492,9676,8693],0); -ELEMENTS[40296] = Fluid3D([9492,10435,9676,9442],0); -ELEMENTS[40297] = Fluid3D([9676,9492,9442,8693],0); -ELEMENTS[40298] = Fluid3D([9391,9492,8693,9782],0); -ELEMENTS[40299] = Fluid3D([9442,9782,10435,10772],0); -ELEMENTS[40300] = Fluid3D([9782,10435,10772,10727],0); -ELEMENTS[40301] = Fluid3D([9782,10435,10727,9795],0); -ELEMENTS[40302] = Fluid3D([9782,10435,9795,9438],0); -ELEMENTS[40303] = Fluid3D([10435,9782,9391,9438],0); -ELEMENTS[40304] = Fluid3D([10435,10772,10727,11676],0); -ELEMENTS[40305] = Fluid3D([5026,4854,5009,4441],0); -ELEMENTS[40306] = Fluid3D([12158,12792,12723,13053],0); -ELEMENTS[40307] = Fluid3D([13496,12729,13328,13500],0); -ELEMENTS[40308] = Fluid3D([13328,13496,13500,13981],0); -ELEMENTS[40309] = Fluid3D([13496,12729,13500,13204],0); -ELEMENTS[40310] = Fluid3D([13500,13496,13204,14150],0); -ELEMENTS[40311] = Fluid3D([13500,13496,14150,14363],0); -ELEMENTS[40312] = Fluid3D([13496,13500,13981,14363],0); -ELEMENTS[40313] = Fluid3D([5086,5360,5350,5452],0); -ELEMENTS[40314] = Fluid3D([4111,3909,3797,3547],0); -ELEMENTS[40315] = Fluid3D([5789,6051,6234,6416],0); -ELEMENTS[40316] = Fluid3D([15791,15770,15248,15386],0); -ELEMENTS[40317] = Fluid3D([14533,14080,14026,13410],0); -ELEMENTS[40318] = Fluid3D([10895,11422,11277,10488],0); -ELEMENTS[40319] = Fluid3D([16772,16297,16465,16468],0); -ELEMENTS[40320] = Fluid3D([9128,8741,9543,9365],0); -ELEMENTS[40321] = Fluid3D([7393,7655,6809,7820],0); -ELEMENTS[40322] = Fluid3D([13382,13557,12755,13928],0); -ELEMENTS[40323] = Fluid3D([15970,15318,15810,15740],0); -ELEMENTS[40324] = Fluid3D([15970,15318,15740,15852],0); -ELEMENTS[40325] = Fluid3D([13528,14029,13631,13113],0); -ELEMENTS[40326] = Fluid3D([5169,5684,4978,5249],0); -ELEMENTS[40327] = Fluid3D([17296,16895,17168,17123],0); -ELEMENTS[40328] = Fluid3D([15624,15340,15829,15524],0); -ELEMENTS[40329] = Fluid3D([7034,6427,7189,6821],0); -ELEMENTS[40330] = Fluid3D([9005,8223,9090,8258],0); -ELEMENTS[40331] = Fluid3D([7928,8841,8584,7967],0); -ELEMENTS[40332] = Fluid3D([6004,6540,5802,5616],0); -ELEMENTS[40333] = Fluid3D([10264,10765,9885,10146],0); -ELEMENTS[40334] = Fluid3D([4946,5249,5169,4606],0); -ELEMENTS[40335] = Fluid3D([5377,5787,5713,5463],0); -ELEMENTS[40336] = Fluid3D([5377,5787,5463,5091],0); -ELEMENTS[40337] = Fluid3D([5787,5713,5463,5743],0); -ELEMENTS[40338] = Fluid3D([5463,5787,5743,5091],0); -ELEMENTS[40339] = Fluid3D([12071,11948,12826,12425],0); -ELEMENTS[40340] = Fluid3D([9022,8044,8491,8764],0); -ELEMENTS[40341] = Fluid3D([10613,11244,11310,10376],0); -ELEMENTS[40342] = Fluid3D([8395,9389,8580,9348],0); -ELEMENTS[40343] = Fluid3D([14785,15107,14784,15439],0); -ELEMENTS[40344] = Fluid3D([15848,16436,16094,15876],0); -ELEMENTS[40345] = Fluid3D([10292,10383,9448,9715],0); -ELEMENTS[40346] = Fluid3D([8737,8250,7836,8692],0); -ELEMENTS[40347] = Fluid3D([5753,6112,5803,5599],0); -ELEMENTS[40348] = Fluid3D([5803,5753,5599,5243],0); -ELEMENTS[40349] = Fluid3D([6112,5803,5599,5742],0); -ELEMENTS[40350] = Fluid3D([5803,5599,5742,5099],0); -ELEMENTS[40351] = Fluid3D([5753,6112,5599,5285],0); -ELEMENTS[40352] = Fluid3D([5599,5753,5285,5243],0); -ELEMENTS[40353] = Fluid3D([5599,6112,5742,5265],0); -ELEMENTS[40354] = Fluid3D([5599,5803,5243,5099],0); -ELEMENTS[40355] = Fluid3D([14125,13539,13282,13660],0); -ELEMENTS[40356] = Fluid3D([3927,4141,3776,4215],0); -ELEMENTS[40357] = Fluid3D([4141,3776,4215,4059],0); -ELEMENTS[40358] = Fluid3D([3776,4215,4059,3713],0); -ELEMENTS[40359] = Fluid3D([3927,4141,4215,4743],0); -ELEMENTS[40360] = Fluid3D([13747,14430,13915,14657],0); -ELEMENTS[40361] = Fluid3D([16215,15617,16102,16035],0); -ELEMENTS[40362] = Fluid3D([10789,11707,11534,10520],0); -ELEMENTS[40363] = Fluid3D([5871,5413,6051,5839],0); -ELEMENTS[40364] = Fluid3D([17027,17378,16928,16976],0); -ELEMENTS[40365] = Fluid3D([7871,8329,8808,7786],0); -ELEMENTS[40366] = Fluid3D([16509,16490,16596,16923],0); -ELEMENTS[40367] = Fluid3D([14155,13483,13403,13038],0); -ELEMENTS[40368] = Fluid3D([3793,3360,3582,3616],0); -ELEMENTS[40369] = Fluid3D([12277,11639,12121,12521],0); -ELEMENTS[40370] = Fluid3D([6269,6018,6341,5639],0); -ELEMENTS[40371] = Fluid3D([9046,8766,8304,8120],0); -ELEMENTS[40372] = Fluid3D([11058,11403,10835,12142],0); -ELEMENTS[40373] = Fluid3D([8678,8547,7924,8428],0); -ELEMENTS[40374] = Fluid3D([17760,17409,17734,17605],0); -ELEMENTS[40375] = Fluid3D([18244,18041,18117,18360],0); -ELEMENTS[40376] = Fluid3D([7662,8334,8439,7778],0); -ELEMENTS[40377] = Fluid3D([9709,10089,10230,10896],0); -ELEMENTS[40378] = Fluid3D([16397,16690,16701,16134],0); -ELEMENTS[40379] = Fluid3D([13903,14180,14065,14592],0); -ELEMENTS[40380] = Fluid3D([14065,13903,14592,14012],0); -ELEMENTS[40381] = Fluid3D([14592,14065,14012,13929],0); -ELEMENTS[40382] = Fluid3D([14592,14065,13929,14809],0); -ELEMENTS[40383] = Fluid3D([14592,14065,14809,14664],0); -ELEMENTS[40384] = Fluid3D([14592,14065,14664,14180],0); -ELEMENTS[40385] = Fluid3D([9536,9467,10245,9055],0); -ELEMENTS[40386] = Fluid3D([8355,8522,8300,9228],0); -ELEMENTS[40387] = Fluid3D([10633,10006,9954,11152],0); -ELEMENTS[40388] = Fluid3D([11371,11184,12111,11884],0); -ELEMENTS[40389] = Fluid3D([10918,11314,10873,12034],0); -ELEMENTS[40390] = Fluid3D([10042,9854,9096,10209],0); -ELEMENTS[40391] = Fluid3D([14956,14493,15083,15160],0); -ELEMENTS[40392] = Fluid3D([13967,13506,13315,14354],0); -ELEMENTS[40393] = Fluid3D([6142,7079,6631,6317],0); -ELEMENTS[40394] = Fluid3D([6142,7079,6317,6724],0); -ELEMENTS[40395] = Fluid3D([6631,6142,6317,5853],0); -ELEMENTS[40396] = Fluid3D([6142,6317,5853,5622],0); -ELEMENTS[40397] = Fluid3D([6142,6317,5622,6153],0); -ELEMENTS[40398] = Fluid3D([18124,18037,17940,18325],0); -ELEMENTS[40399] = Fluid3D([4621,4434,4791,4215],0); -ELEMENTS[40400] = Fluid3D([6186,6564,5930,5775],0); -ELEMENTS[40401] = Fluid3D([17032,16644,16689,16922],0); -ELEMENTS[40402] = Fluid3D([4314,4379,4850,4752],0); -ELEMENTS[40403] = Fluid3D([15415,15463,15234,14701],0); -ELEMENTS[40404] = Fluid3D([16057,15794,16198,16481],0); -ELEMENTS[40405] = Fluid3D([11992,12622,11560,12390],0); -ELEMENTS[40406] = Fluid3D([9717,8844,9169,9787],0); -ELEMENTS[40407] = Fluid3D([13749,14194,13978,13244],0); -ELEMENTS[40408] = Fluid3D([14661,13791,14296,14665],0); -ELEMENTS[40409] = Fluid3D([2271,2086,2087,2080],0); -ELEMENTS[40410] = Fluid3D([11352,10769,10414,10777],0); -ELEMENTS[40411] = Fluid3D([18127,18035,17812,17879],0); -ELEMENTS[40412] = Fluid3D([14856,14500,13957,14086],0); -ELEMENTS[40413] = Fluid3D([7267,7367,7478,8201],0); -ELEMENTS[40414] = Fluid3D([7972,8783,8492,8455],0); -ELEMENTS[40415] = Fluid3D([10893,9940,9954,10094],0); -ELEMENTS[40416] = Fluid3D([12616,11768,12300,11964],0); -ELEMENTS[40417] = Fluid3D([14171,14226,14721,15092],0); -ELEMENTS[40418] = Fluid3D([2503,2471,2601,2778],0); -ELEMENTS[40419] = Fluid3D([12649,12665,12231,12203],0); -ELEMENTS[40420] = Fluid3D([16323,16580,16655,16157],0); -ELEMENTS[40421] = Fluid3D([16356,16303,15957,16700],0); -ELEMENTS[40422] = Fluid3D([12689,13337,12538,12174],0); -ELEMENTS[40423] = Fluid3D([13090,13346,13467,14385],0); -ELEMENTS[40424] = Fluid3D([5483,5107,5087,4710],0); -ELEMENTS[40425] = Fluid3D([10937,9984,10882,10233],0); -ELEMENTS[40426] = Fluid3D([15983,15571,15510,15526],0); -ELEMENTS[40427] = Fluid3D([18375,18388,18522,18417],0); -ELEMENTS[40428] = Fluid3D([10393,10248,11332,10516],0); -ELEMENTS[40429] = Fluid3D([13066,12390,11992,12387],0); -ELEMENTS[40430] = Fluid3D([1759,1744,1791,1664],0); -ELEMENTS[40431] = Fluid3D([1744,1791,1664,1625],0); -ELEMENTS[40432] = Fluid3D([1664,1744,1625,1759],0); -ELEMENTS[40433] = Fluid3D([10369,10110,10898,11442],0); -ELEMENTS[40434] = Fluid3D([15750,15547,15330,15052],0); -ELEMENTS[40435] = Fluid3D([17536,17499,17024,17338],0); -ELEMENTS[40436] = Fluid3D([17536,17499,17338,17656],0); -ELEMENTS[40437] = Fluid3D([17499,17024,17338,16866],0); -ELEMENTS[40438] = Fluid3D([11881,11210,11934,12459],0); -ELEMENTS[40439] = Fluid3D([13598,14241,14409,14588],0); -ELEMENTS[40440] = Fluid3D([14241,14409,14588,14808],0); -ELEMENTS[40441] = Fluid3D([13598,14241,14588,14381],0); -ELEMENTS[40442] = Fluid3D([10071,9781,10528,11105],0); -ELEMENTS[40443] = Fluid3D([18454,18293,18354,18204],0); -ELEMENTS[40444] = Fluid3D([13680,14169,13633,13308],0); -ELEMENTS[40445] = Fluid3D([6562,6818,6348,6103],0); -ELEMENTS[40446] = Fluid3D([6562,6818,6103,6729],0); -ELEMENTS[40447] = Fluid3D([6103,6562,6729,6204],0); -ELEMENTS[40448] = Fluid3D([6348,6562,6103,6043],0); -ELEMENTS[40449] = Fluid3D([6562,6103,6043,6204],0); -ELEMENTS[40450] = Fluid3D([10210,9853,9798,10555],0); -ELEMENTS[40451] = Fluid3D([13047,12569,13472,13432],0); -ELEMENTS[40452] = Fluid3D([15683,15351,14938,15545],0); -ELEMENTS[40453] = Fluid3D([5279,4694,4952,4918],0); -ELEMENTS[40454] = Fluid3D([3369,3534,3406,3801],0); -ELEMENTS[40455] = Fluid3D([12263,12426,11966,11457],0); -ELEMENTS[40456] = Fluid3D([12263,12426,11457,12049],0); -ELEMENTS[40457] = Fluid3D([12426,11457,12049,11170],0); -ELEMENTS[40458] = Fluid3D([11457,12049,11170,11027],0); -ELEMENTS[40459] = Fluid3D([11170,11457,11027,10108],0); -ELEMENTS[40460] = Fluid3D([3335,3594,3789,3526],0); -ELEMENTS[40461] = Fluid3D([14050,13266,13186,13699],0); -ELEMENTS[40462] = Fluid3D([15548,15055,15640,15037],0); -ELEMENTS[40463] = Fluid3D([7024,6528,6438,7416],0); -ELEMENTS[40464] = Fluid3D([7141,7460,8091,7750],0); -ELEMENTS[40465] = Fluid3D([3133,2999,2820,2910],0); -ELEMENTS[40466] = Fluid3D([6770,6230,6172,5950],0); -ELEMENTS[40467] = Fluid3D([9142,8188,8589,8221],0); -ELEMENTS[40468] = Fluid3D([8188,8589,8221,7820],0); -ELEMENTS[40469] = Fluid3D([8589,8221,7820,7655],0); -ELEMENTS[40470] = Fluid3D([8589,9142,8221,8750],0); -ELEMENTS[40471] = Fluid3D([8221,8589,8750,8850],0); -ELEMENTS[40472] = Fluid3D([8221,8589,8850,7655],0); -ELEMENTS[40473] = Fluid3D([13387,12880,13244,13947],0); -ELEMENTS[40474] = Fluid3D([13020,13061,12406,13360],0); -ELEMENTS[40475] = Fluid3D([18309,18128,18179,17802],0); -ELEMENTS[40476] = Fluid3D([12657,13217,13028,13933],0); -ELEMENTS[40477] = Fluid3D([17271,17387,17464,17035],0); -ELEMENTS[40478] = Fluid3D([8651,8798,8767,9802],0); -ELEMENTS[40479] = Fluid3D([15854,16136,16355,15749],0); -ELEMENTS[40480] = Fluid3D([7524,8430,8090,7784],0); -ELEMENTS[40481] = Fluid3D([8430,8090,7784,9179],0); -ELEMENTS[40482] = Fluid3D([8090,7524,7784,6901],0); -ELEMENTS[40483] = Fluid3D([7005,6659,6156,6664],0); -ELEMENTS[40484] = Fluid3D([14359,15064,14830,15140],0); -ELEMENTS[40485] = Fluid3D([16605,16839,16507,16957],0); -ELEMENTS[40486] = Fluid3D([15226,15804,15495,15891],0); -ELEMENTS[40487] = Fluid3D([11800,11823,12704,12015],0); -ELEMENTS[40488] = Fluid3D([15599,15385,16000,15364],0); -ELEMENTS[40489] = Fluid3D([15052,15094,15609,15547],0); -ELEMENTS[40490] = Fluid3D([14634,14589,13858,14479],0); -ELEMENTS[40491] = Fluid3D([3154,3460,3103,3012],0); -ELEMENTS[40492] = Fluid3D([18223,17999,18037,18107],0); -ELEMENTS[40493] = Fluid3D([11169,11110,10255,10392],0); -ELEMENTS[40494] = Fluid3D([8935,9406,9958,9533],0); -ELEMENTS[40495] = Fluid3D([5893,6251,6306,6661],0); -ELEMENTS[40496] = Fluid3D([9235,9456,8537,9903],0); -ELEMENTS[40497] = Fluid3D([18207,18038,17996,18041],0); -ELEMENTS[40498] = Fluid3D([7220,6927,7456,6768],0); -ELEMENTS[40499] = Fluid3D([7471,7821,8389,7871],0); -ELEMENTS[40500] = Fluid3D([17670,17936,17839,18067],0); -ELEMENTS[40501] = Fluid3D([11081,11561,11757,10705],0); -ELEMENTS[40502] = Fluid3D([2594,2803,2978,2948],0); -ELEMENTS[40503] = Fluid3D([6670,7278,7141,7514],0); -ELEMENTS[40504] = Fluid3D([7141,6670,7514,7221],0); -ELEMENTS[40505] = Fluid3D([17548,17243,17688,17424],0); -ELEMENTS[40506] = Fluid3D([17688,17548,17424,17675],0); -ELEMENTS[40507] = Fluid3D([17424,17688,17675,17462],0); -ELEMENTS[40508] = Fluid3D([17548,17243,17424,17326],0); -ELEMENTS[40509] = Fluid3D([17548,17424,17675,17326],0); -ELEMENTS[40510] = Fluid3D([17424,17688,17462,17243],0); -ELEMENTS[40511] = Fluid3D([10456,11428,10844,11509],0); -ELEMENTS[40512] = Fluid3D([7858,7258,7217,7022],0); -ELEMENTS[40513] = Fluid3D([7217,7858,7022,7406],0); -ELEMENTS[40514] = Fluid3D([7858,7258,7022,7593],0); -ELEMENTS[40515] = Fluid3D([7022,7858,7593,7731],0); -ELEMENTS[40516] = Fluid3D([7858,7258,7593,8042],0); -ELEMENTS[40517] = Fluid3D([7258,7022,7593,6987],0); -ELEMENTS[40518] = Fluid3D([7258,7593,8042,6987],0); -ELEMENTS[40519] = Fluid3D([13825,14075,14640,14018],0); -ELEMENTS[40520] = Fluid3D([9680,9817,9009,10098],0); -ELEMENTS[40521] = Fluid3D([15033,15438,15016,15616],0); -ELEMENTS[40522] = Fluid3D([3019,3169,2935,3497],0); -ELEMENTS[40523] = Fluid3D([14613,14103,13975,13691],0); -ELEMENTS[40524] = Fluid3D([2406,2475,2705,2582],0); -ELEMENTS[40525] = Fluid3D([6306,5769,5887,6711],0); -ELEMENTS[40526] = Fluid3D([15514,15826,15446,16018],0); -ELEMENTS[40527] = Fluid3D([5115,5280,5255,4688],0); -ELEMENTS[40528] = Fluid3D([5115,5280,4688,4722],0); -ELEMENTS[40529] = Fluid3D([4387,4127,4109,3851],0); -ELEMENTS[40530] = Fluid3D([8830,7905,8382,8330],0); -ELEMENTS[40531] = Fluid3D([7536,7416,7170,7788],0); -ELEMENTS[40532] = Fluid3D([7170,7536,7788,7691],0); -ELEMENTS[40533] = Fluid3D([7788,7170,7691,6902],0); -ELEMENTS[40534] = Fluid3D([7788,7170,6902,7540],0); -ELEMENTS[40535] = Fluid3D([7788,7170,7540,7407],0); -ELEMENTS[40536] = Fluid3D([7536,7788,7691,8378],0); -ELEMENTS[40537] = Fluid3D([7087,6781,6306,6662],0); -ELEMENTS[40538] = Fluid3D([6781,6306,6662,5887],0); -ELEMENTS[40539] = Fluid3D([7087,6781,6662,7866],0); -ELEMENTS[40540] = Fluid3D([16425,16198,16338,16151],0); -ELEMENTS[40541] = Fluid3D([5358,5173,5165,4761],0); -ELEMENTS[40542] = Fluid3D([5165,5358,4761,4624],0); -ELEMENTS[40543] = Fluid3D([5358,5173,4761,5037],0); -ELEMENTS[40544] = Fluid3D([4761,5358,5037,4637],0); -ELEMENTS[40545] = Fluid3D([5358,5173,5037,5385],0); -ELEMENTS[40546] = Fluid3D([5037,5358,5385,4637],0); -ELEMENTS[40547] = Fluid3D([5173,4761,5037,4633],0); -ELEMENTS[40548] = Fluid3D([4761,5037,4633,4324],0); -ELEMENTS[40549] = Fluid3D([5037,5173,4633,5133],0); -ELEMENTS[40550] = Fluid3D([5173,4761,4633,4682],0); -ELEMENTS[40551] = Fluid3D([4761,4633,4682,4300],0); -ELEMENTS[40552] = Fluid3D([4633,4682,4300,4349],0); -ELEMENTS[40553] = Fluid3D([4761,4633,4300,4324],0); -ELEMENTS[40554] = Fluid3D([4633,4300,4324,4497],0); -ELEMENTS[40555] = Fluid3D([4300,4633,4349,4497],0); -ELEMENTS[40556] = Fluid3D([4682,4761,4300,4450],0); -ELEMENTS[40557] = Fluid3D([4300,4682,4450,4223],0); -ELEMENTS[40558] = Fluid3D([4682,4450,4223,4977],0); -ELEMENTS[40559] = Fluid3D([4682,4761,4450,5165],0); -ELEMENTS[40560] = Fluid3D([4300,4682,4223,4349],0); -ELEMENTS[40561] = Fluid3D([4450,4300,4223,3692],0); -ELEMENTS[40562] = Fluid3D([4633,5173,4682,4954],0); -ELEMENTS[40563] = Fluid3D([4633,5173,4954,5133],0); -ELEMENTS[40564] = Fluid3D([5173,4761,4682,5165],0); -ELEMENTS[40565] = Fluid3D([4633,4349,4497,4954],0); -ELEMENTS[40566] = Fluid3D([4497,4633,4954,5133],0); -ELEMENTS[40567] = Fluid3D([4633,4349,4954,4682],0); -ELEMENTS[40568] = Fluid3D([13957,13717,13288,14086],0); -ELEMENTS[40569] = Fluid3D([16271,16214,15904,16635],0); -ELEMENTS[40570] = Fluid3D([6256,7063,6639,6445],0); -ELEMENTS[40571] = Fluid3D([16778,16675,17094,17181],0); -ELEMENTS[40572] = Fluid3D([17094,16778,17181,17127],0); -ELEMENTS[40573] = Fluid3D([17181,17094,17127,17459],0); -ELEMENTS[40574] = Fluid3D([11731,11812,12221,12710],0); -ELEMENTS[40575] = Fluid3D([5788,6459,6297,5835],0); -ELEMENTS[40576] = Fluid3D([7231,7287,7604,6536],0); -ELEMENTS[40577] = Fluid3D([12158,12394,13053,13027],0); -ELEMENTS[40578] = Fluid3D([11983,11440,12482,11908],0); -ELEMENTS[40579] = Fluid3D([11983,11440,11908,11433],0); -ELEMENTS[40580] = Fluid3D([12419,11716,12661,12427],0); -ELEMENTS[40581] = Fluid3D([14309,14230,14576,15114],0); -ELEMENTS[40582] = Fluid3D([14204,14740,15113,14702],0); -ELEMENTS[40583] = Fluid3D([5852,5314,5601,5644],0); -ELEMENTS[40584] = Fluid3D([10407,9911,10479,10432],0); -ELEMENTS[40585] = Fluid3D([4714,5316,4845,5008],0); -ELEMENTS[40586] = Fluid3D([10937,11696,12000,11973],0); -ELEMENTS[40587] = Fluid3D([16500,16519,16468,16913],0); -ELEMENTS[40588] = Fluid3D([3800,3446,3353,3273],0); -ELEMENTS[40589] = Fluid3D([5793,6304,6017,6209],0); -ELEMENTS[40590] = Fluid3D([11201,12121,11382,11639],0); -ELEMENTS[40591] = Fluid3D([13488,12614,13462,13460],0); -ELEMENTS[40592] = Fluid3D([15205,14733,14342,14741],0); -ELEMENTS[40593] = Fluid3D([6312,6564,7042,6072],0); -ELEMENTS[40594] = Fluid3D([7895,8112,7771,7234],0); -ELEMENTS[40595] = Fluid3D([8089,8698,9097,8794],0); -ELEMENTS[40596] = Fluid3D([3906,4331,3897,3832],0); -ELEMENTS[40597] = Fluid3D([17572,17188,17377,17476],0); -ELEMENTS[40598] = Fluid3D([9335,8712,9313,9858],0); -ELEMENTS[40599] = Fluid3D([17597,17785,17372,17503],0); -ELEMENTS[40600] = Fluid3D([12654,12007,11876,12721],0); -ELEMENTS[40601] = Fluid3D([18643,18651,18584,18637],0); -ELEMENTS[40602] = Fluid3D([18643,18651,18637,18677],0); -ELEMENTS[40603] = Fluid3D([18651,18637,18677,18644],0); -ELEMENTS[40604] = Fluid3D([18637,18677,18644,18662],0); -ELEMENTS[40605] = Fluid3D([18644,18637,18662,18583],0); -ELEMENTS[40606] = Fluid3D([18637,18677,18662,18643],0); -ELEMENTS[40607] = Fluid3D([18651,18637,18644,18584],0); -ELEMENTS[40608] = Fluid3D([6200,6793,6204,6198],0); -ELEMENTS[40609] = Fluid3D([6200,6793,6198,6657],0); -ELEMENTS[40610] = Fluid3D([6793,6204,6198,6729],0); -ELEMENTS[40611] = Fluid3D([15516,15228,14916,14310],0); -ELEMENTS[40612] = Fluid3D([14821,15076,14447,15143],0); -ELEMENTS[40613] = Fluid3D([7805,6966,7403,7309],0); -ELEMENTS[40614] = Fluid3D([10122,10838,10871,11502],0); -ELEMENTS[40615] = Fluid3D([9821,9488,10552,9945],0); -ELEMENTS[40616] = Fluid3D([4205,4416,4516,4273],0); -ELEMENTS[40617] = Fluid3D([4416,4516,4273,4606],0); -ELEMENTS[40618] = Fluid3D([4516,4205,4273,4089],0); -ELEMENTS[40619] = Fluid3D([4516,4273,4606,4431],0); -ELEMENTS[40620] = Fluid3D([4273,4606,4431,3876],0); -ELEMENTS[40621] = Fluid3D([10114,10711,11121,10466],0); -ELEMENTS[40622] = Fluid3D([10114,10711,10466,9792],0); -ELEMENTS[40623] = Fluid3D([10466,10114,9792,9616],0); -ELEMENTS[40624] = Fluid3D([10114,10711,9792,9475],0); -ELEMENTS[40625] = Fluid3D([11121,10114,10466,10472],0); -ELEMENTS[40626] = Fluid3D([10711,10466,9792,10501],0); -ELEMENTS[40627] = Fluid3D([10466,9792,10501,9546],0); -ELEMENTS[40628] = Fluid3D([9792,10711,10501,10234],0); -ELEMENTS[40629] = Fluid3D([10501,9792,10234,10089],0); -ELEMENTS[40630] = Fluid3D([10234,10501,10089,11149],0); -ELEMENTS[40631] = Fluid3D([10234,10501,11149,10711],0); -ELEMENTS[40632] = Fluid3D([10501,9792,10089,9546],0); -ELEMENTS[40633] = Fluid3D([10711,10466,10501,11429],0); -ELEMENTS[40634] = Fluid3D([10711,10466,11429,11121],0); -ELEMENTS[40635] = Fluid3D([11429,10711,11121,11769],0); -ELEMENTS[40636] = Fluid3D([11121,11429,11769,12325],0); -ELEMENTS[40637] = Fluid3D([11429,10711,11769,11963],0); -ELEMENTS[40638] = Fluid3D([10501,10711,11429,11149],0); -ELEMENTS[40639] = Fluid3D([12312,12889,12519,11442],0); -ELEMENTS[40640] = Fluid3D([11308,10487,10539,9712],0); -ELEMENTS[40641] = Fluid3D([2827,2532,2514,2553],0); -ELEMENTS[40642] = Fluid3D([2532,2514,2553,2318],0); -ELEMENTS[40643] = Fluid3D([2514,2553,2318,2378],0); -ELEMENTS[40644] = Fluid3D([2318,2514,2378,2471],0); -ELEMENTS[40645] = Fluid3D([2553,2318,2378,2327],0); -ELEMENTS[40646] = Fluid3D([2318,2378,2327,2151],0); -ELEMENTS[40647] = Fluid3D([2378,2327,2151,2137],0); -ELEMENTS[40648] = Fluid3D([2514,2827,2553,2872],0); -ELEMENTS[40649] = Fluid3D([2514,2378,2471,2872],0); -ELEMENTS[40650] = Fluid3D([15640,15181,15745,15793],0); -ELEMENTS[40651] = Fluid3D([12545,12581,13266,12350],0); -ELEMENTS[40652] = Fluid3D([6853,6616,7141,6281],0); -ELEMENTS[40653] = Fluid3D([15470,14764,15072,15062],0); -ELEMENTS[40654] = Fluid3D([10698,9982,10630,9985],0); -ELEMENTS[40655] = Fluid3D([6709,6172,5950,6770],0); -ELEMENTS[40656] = Fluid3D([8566,9464,8643,8552],0); -ELEMENTS[40657] = Fluid3D([12103,12029,11136,11833],0); -ELEMENTS[40658] = Fluid3D([12029,11136,11833,12433],0); -ELEMENTS[40659] = Fluid3D([12312,11393,12010,11442],0); -ELEMENTS[40660] = Fluid3D([17963,17827,17569,17728],0); -ELEMENTS[40661] = Fluid3D([16903,17070,16685,16814],0); -ELEMENTS[40662] = Fluid3D([10051,10113,9744,10781],0); -ELEMENTS[40663] = Fluid3D([10174,9438,10794,10435],0); -ELEMENTS[40664] = Fluid3D([11506,11209,11663,10815],0); -ELEMENTS[40665] = Fluid3D([5952,5621,5803,5099],0); -ELEMENTS[40666] = Fluid3D([3518,3960,3646,3692],0); -ELEMENTS[40667] = Fluid3D([15878,15712,16315,15974],0); -ELEMENTS[40668] = Fluid3D([11369,11485,10597,10853],0); -ELEMENTS[40669] = Fluid3D([3195,3550,3084,3152],0); -ELEMENTS[40670] = Fluid3D([16021,16507,16523,16605],0); -ELEMENTS[40671] = Fluid3D([5004,4550,5038,4968],0); -ELEMENTS[40672] = Fluid3D([15312,15324,15930,15083],0); -ELEMENTS[40673] = Fluid3D([15312,15324,15083,14706],0); -ELEMENTS[40674] = Fluid3D([15083,15312,14706,14478],0); -ELEMENTS[40675] = Fluid3D([15930,15312,15083,15490],0); -ELEMENTS[40676] = Fluid3D([15312,15083,15490,15081],0); -ELEMENTS[40677] = Fluid3D([13544,12766,12762,12624],0); -ELEMENTS[40678] = Fluid3D([12766,12762,12624,11866],0); -ELEMENTS[40679] = Fluid3D([12762,13544,12624,13908],0); -ELEMENTS[40680] = Fluid3D([12762,12624,11866,11947],0); -ELEMENTS[40681] = Fluid3D([15141,14424,14448,14654],0); -ELEMENTS[40682] = Fluid3D([15674,15792,16172,16164],0); -ELEMENTS[40683] = Fluid3D([10316,10829,11242,10678],0); -ELEMENTS[40684] = Fluid3D([5757,5261,5626,5017],0); -ELEMENTS[40685] = Fluid3D([8582,8883,9279,9437],0); -ELEMENTS[40686] = Fluid3D([17633,17307,17489,17682],0); -ELEMENTS[40687] = Fluid3D([9877,9761,10720,9902],0); -ELEMENTS[40688] = Fluid3D([7996,9000,8556,8247],0); -ELEMENTS[40689] = Fluid3D([7749,7485,7241,8044],0); -ELEMENTS[40690] = Fluid3D([2272,2365,2380,2673],0); -ELEMENTS[40691] = Fluid3D([10391,11072,10426,10171],0); -ELEMENTS[40692] = Fluid3D([11072,10426,10171,10853],0); -ELEMENTS[40693] = Fluid3D([12089,11757,12681,12014],0); -ELEMENTS[40694] = Fluid3D([11312,10922,11222,12052],0); -ELEMENTS[40695] = Fluid3D([11331,11246,10599,10498],0); -ELEMENTS[40696] = Fluid3D([8519,8957,7723,8081],0); -ELEMENTS[40697] = Fluid3D([16948,17183,16806,17301],0); -ELEMENTS[40698] = Fluid3D([17183,16806,17301,17105],0); -ELEMENTS[40699] = Fluid3D([13265,13285,12390,13196],0); -ELEMENTS[40700] = Fluid3D([14492,14640,14018,13792],0); -ELEMENTS[40701] = Fluid3D([4914,4690,4956,5369],0); -ELEMENTS[40702] = Fluid3D([13769,14199,14639,14466],0); -ELEMENTS[40703] = Fluid3D([15384,15241,15888,15556],0); -ELEMENTS[40704] = Fluid3D([15384,15241,15556,14618],0); -ELEMENTS[40705] = Fluid3D([15888,15384,15556,16249],0); -ELEMENTS[40706] = Fluid3D([15556,15384,14618,15128],0); -ELEMENTS[40707] = Fluid3D([5311,4752,5370,4870],0); -ELEMENTS[40708] = Fluid3D([4307,3958,4465,4051],0); -ELEMENTS[40709] = Fluid3D([4465,4307,4051,4699],0); -ELEMENTS[40710] = Fluid3D([4307,3958,4051,3983],0); -ELEMENTS[40711] = Fluid3D([4051,4307,3983,4699],0); -ELEMENTS[40712] = Fluid3D([4602,4387,4109,4568],0); -ELEMENTS[40713] = Fluid3D([4602,4387,4568,4996],0); -ELEMENTS[40714] = Fluid3D([4568,4602,4996,4525],0); -ELEMENTS[40715] = Fluid3D([9512,8444,8968,9373],0); -ELEMENTS[40716] = Fluid3D([4250,4063,3762,3864],0); -ELEMENTS[40717] = Fluid3D([5706,6216,5817,5606],0); -ELEMENTS[40718] = Fluid3D([3996,3952,4145,3575],0); -ELEMENTS[40719] = Fluid3D([11473,11164,11978,10638],0); -ELEMENTS[40720] = Fluid3D([16327,16599,16414,16979],0); -ELEMENTS[40721] = Fluid3D([13591,13003,12866,12875],0); -ELEMENTS[40722] = Fluid3D([15742,15215,15034,15771],0); -ELEMENTS[40723] = Fluid3D([15742,15215,15771,15690],0); -ELEMENTS[40724] = Fluid3D([15771,15742,15690,16463],0); -ELEMENTS[40725] = Fluid3D([15215,15771,15690,15343],0); -ELEMENTS[40726] = Fluid3D([9953,9857,9655,9000],0); -ELEMENTS[40727] = Fluid3D([3080,2811,3126,3102],0); -ELEMENTS[40728] = Fluid3D([2811,3126,3102,3068],0); -ELEMENTS[40729] = Fluid3D([3080,2811,3102,3065],0); -ELEMENTS[40730] = Fluid3D([10777,11579,11352,10769],0); -ELEMENTS[40731] = Fluid3D([5149,5135,4796,4804],0); -ELEMENTS[40732] = Fluid3D([10297,10438,9383,9883],0); -ELEMENTS[40733] = Fluid3D([9383,10297,9883,9202],0); -ELEMENTS[40734] = Fluid3D([10297,10438,9883,11270],0); -ELEMENTS[40735] = Fluid3D([11132,10090,10737,10920],0); -ELEMENTS[40736] = Fluid3D([8720,8867,9418,9612],0); -ELEMENTS[40737] = Fluid3D([13560,14068,13988,14377],0); -ELEMENTS[40738] = Fluid3D([14231,13761,13232,13809],0); -ELEMENTS[40739] = Fluid3D([9468,9118,8851,9993],0); -ELEMENTS[40740] = Fluid3D([11580,12204,12252,12503],0); -ELEMENTS[40741] = Fluid3D([5581,5494,5517,6132],0); -ELEMENTS[40742] = Fluid3D([5517,5581,6132,5855],0); -ELEMENTS[40743] = Fluid3D([12752,12000,11973,11928],0); -ELEMENTS[40744] = Fluid3D([16491,16456,16227,16893],0); -ELEMENTS[40745] = Fluid3D([16049,15656,16120,16090],0); -ELEMENTS[40746] = Fluid3D([4381,4495,3900,4098],0); -ELEMENTS[40747] = Fluid3D([4381,4495,4098,4615],0); -ELEMENTS[40748] = Fluid3D([4381,4495,4615,5043],0); -ELEMENTS[40749] = Fluid3D([14465,14355,15062,15047],0); -ELEMENTS[40750] = Fluid3D([4448,4425,4794,4930],0); -ELEMENTS[40751] = Fluid3D([16160,16152,15892,16555],0); -ELEMENTS[40752] = Fluid3D([8573,8905,8509,9014],0); -ELEMENTS[40753] = Fluid3D([8509,8573,9014,8079],0); -ELEMENTS[40754] = Fluid3D([8573,9014,8079,8914],0); -ELEMENTS[40755] = Fluid3D([8573,9014,8914,9877],0); -ELEMENTS[40756] = Fluid3D([9014,8914,9877,9088],0); -ELEMENTS[40757] = Fluid3D([9014,8914,9088,8079],0); -ELEMENTS[40758] = Fluid3D([8914,9877,9088,9178],0); -ELEMENTS[40759] = Fluid3D([9088,8914,9178,8309],0); -ELEMENTS[40760] = Fluid3D([8914,9178,8309,8849],0); -ELEMENTS[40761] = Fluid3D([9088,8914,8309,8079],0); -ELEMENTS[40762] = Fluid3D([8914,8309,8079,8573],0); -ELEMENTS[40763] = Fluid3D([8914,9178,8849,9877],0); -ELEMENTS[40764] = Fluid3D([8309,8914,8849,8573],0); -ELEMENTS[40765] = Fluid3D([8914,8849,8573,9877],0); -ELEMENTS[40766] = Fluid3D([15362,14996,14815,14882],0); -ELEMENTS[40767] = Fluid3D([15512,15427,14810,14936],0); -ELEMENTS[40768] = Fluid3D([14196,13574,13933,13028],0); -ELEMENTS[40769] = Fluid3D([7880,7451,7148,8035],0); -ELEMENTS[40770] = Fluid3D([7148,7880,8035,7189],0); -ELEMENTS[40771] = Fluid3D([7880,7451,8035,8427],0); -ELEMENTS[40772] = Fluid3D([8035,7880,8427,8819],0); -ELEMENTS[40773] = Fluid3D([8035,7880,8819,8353],0); -ELEMENTS[40774] = Fluid3D([8427,8035,8819,9151],0); -ELEMENTS[40775] = Fluid3D([13057,13188,13499,13804],0); -ELEMENTS[40776] = Fluid3D([13499,13057,13804,14021],0); -ELEMENTS[40777] = Fluid3D([13057,13188,13804,12948],0); -ELEMENTS[40778] = Fluid3D([16977,17405,17237,17258],0); -ELEMENTS[40779] = Fluid3D([9811,9223,9669,8756],0); -ELEMENTS[40780] = Fluid3D([6463,6220,6802,6093],0); -ELEMENTS[40781] = Fluid3D([13995,13667,13842,14802],0); -ELEMENTS[40782] = Fluid3D([9796,9885,9231,8917],0); -ELEMENTS[40783] = Fluid3D([14169,13652,13879,13633],0); -ELEMENTS[40784] = Fluid3D([6130,6092,6600,5532],0); -ELEMENTS[40785] = Fluid3D([9117,9801,9185,8289],0); -ELEMENTS[40786] = Fluid3D([3890,3596,3760,4217],0); -ELEMENTS[40787] = Fluid3D([5395,5374,4969,4756],0); -ELEMENTS[40788] = Fluid3D([10050,10912,11058,11028],0); -ELEMENTS[40789] = Fluid3D([13295,14015,13841,14618],0); -ELEMENTS[40790] = Fluid3D([6360,6571,6676,5747],0); -ELEMENTS[40791] = Fluid3D([14886,15467,14971,14998],0); -ELEMENTS[40792] = Fluid3D([15910,16195,15537,15668],0); -ELEMENTS[40793] = Fluid3D([4802,4862,5057,4423],0); -ELEMENTS[40794] = Fluid3D([6140,6366,6982,6832],0); -ELEMENTS[40795] = Fluid3D([6366,6982,6832,7390],0); -ELEMENTS[40796] = Fluid3D([6140,6366,6832,6641],0); -ELEMENTS[40797] = Fluid3D([6366,6832,6641,7390],0); -ELEMENTS[40798] = Fluid3D([17417,17722,17470,17787],0); -ELEMENTS[40799] = Fluid3D([11560,11982,11020,11551],0); -ELEMENTS[40800] = Fluid3D([11020,11560,11551,10820],0); -ELEMENTS[40801] = Fluid3D([9584,10429,9572,10026],0); -ELEMENTS[40802] = Fluid3D([9572,9584,10026,9186],0); -ELEMENTS[40803] = Fluid3D([9584,10429,10026,10372],0); -ELEMENTS[40804] = Fluid3D([12788,12773,12669,11849],0); -ELEMENTS[40805] = Fluid3D([14466,13823,13664,13757],0); -ELEMENTS[40806] = Fluid3D([13823,13664,13757,12850],0); -ELEMENTS[40807] = Fluid3D([14466,13823,13757,14612],0); -ELEMENTS[40808] = Fluid3D([2432,2290,2171,2260],0); -ELEMENTS[40809] = Fluid3D([12331,12119,13138,13041],0); -ELEMENTS[40810] = Fluid3D([12119,13138,13041,12373],0); -ELEMENTS[40811] = Fluid3D([16284,16672,16512,16779],0); -ELEMENTS[40812] = Fluid3D([17841,17624,17428,17650],0); -ELEMENTS[40813] = Fluid3D([17428,17841,17650,17512],0); -ELEMENTS[40814] = Fluid3D([9419,9519,9710,10336],0); -ELEMENTS[40815] = Fluid3D([6950,7519,7856,7745],0); -ELEMENTS[40816] = Fluid3D([8160,8431,8336,7599],0); -ELEMENTS[40817] = Fluid3D([15800,15929,15702,15116],0); -ELEMENTS[40818] = Fluid3D([13361,13795,14254,13621],0); -ELEMENTS[40819] = Fluid3D([11850,11359,10909,11463],0); -ELEMENTS[40820] = Fluid3D([17789,17678,17444,17589],0); -ELEMENTS[40821] = Fluid3D([17444,17789,17589,17799],0); -ELEMENTS[40822] = Fluid3D([5839,6468,6051,6432],0); -ELEMENTS[40823] = Fluid3D([16946,16482,16755,16581],0); -ELEMENTS[40824] = Fluid3D([4937,4791,5155,5352],0); -ELEMENTS[40825] = Fluid3D([11162,10966,10206,10834],0); -ELEMENTS[40826] = Fluid3D([11162,10966,10834,11713],0); -ELEMENTS[40827] = Fluid3D([10966,10834,11713,10402],0); -ELEMENTS[40828] = Fluid3D([10966,10834,10402,10206],0); -ELEMENTS[40829] = Fluid3D([11713,10966,10402,11542],0); -ELEMENTS[40830] = Fluid3D([11162,10966,11713,11789],0); -ELEMENTS[40831] = Fluid3D([10966,11713,11789,11542],0); -ELEMENTS[40832] = Fluid3D([10402,10966,10206,10705],0); -ELEMENTS[40833] = Fluid3D([10402,10966,10705,11542],0); -ELEMENTS[40834] = Fluid3D([12018,12956,12646,12214],0); -ELEMENTS[40835] = Fluid3D([11997,12763,11965,13036],0); -ELEMENTS[40836] = Fluid3D([11997,12763,13036,12767],0); -ELEMENTS[40837] = Fluid3D([8751,8224,9104,8163],0); -ELEMENTS[40838] = Fluid3D([3413,3015,3370,3314],0); -ELEMENTS[40839] = Fluid3D([9057,9041,8076,8807],0); -ELEMENTS[40840] = Fluid3D([9057,9041,8807,9811],0); -ELEMENTS[40841] = Fluid3D([8807,9057,9811,9223],0); -ELEMENTS[40842] = Fluid3D([9811,8807,9223,8756],0); -ELEMENTS[40843] = Fluid3D([16557,16848,16348,16542],0); -ELEMENTS[40844] = Fluid3D([10641,10369,11393,10800],0); -ELEMENTS[40845] = Fluid3D([16162,16046,16423,16435],0); -ELEMENTS[40846] = Fluid3D([16162,16046,16435,15914],0); -ELEMENTS[40847] = Fluid3D([16423,16162,16435,16831],0); -ELEMENTS[40848] = Fluid3D([16435,16423,16831,16046],0); -ELEMENTS[40849] = Fluid3D([7171,8073,7868,8216],0); -ELEMENTS[40850] = Fluid3D([8073,7868,8216,8591],0); -ELEMENTS[40851] = Fluid3D([16518,16232,16583,16761],0); -ELEMENTS[40852] = Fluid3D([17452,17734,17573,17409],0); -ELEMENTS[40853] = Fluid3D([12047,11490,11499,12414],0); -ELEMENTS[40854] = Fluid3D([17793,17801,17509,17966],0); -ELEMENTS[40855] = Fluid3D([8884,9618,8612,9463],0); -ELEMENTS[40856] = Fluid3D([14313,14485,14952,14877],0); -ELEMENTS[40857] = Fluid3D([14944,14420,15186,14176],0); -ELEMENTS[40858] = Fluid3D([16106,15456,15697,15553],0); -ELEMENTS[40859] = Fluid3D([3288,3216,2943,3245],0); -ELEMENTS[40860] = Fluid3D([12426,12202,13171,13126],0); -ELEMENTS[40861] = Fluid3D([6918,6082,6081,6368],0); -ELEMENTS[40862] = Fluid3D([3330,3423,3612,3863],0); -ELEMENTS[40863] = Fluid3D([12247,11741,12335,12639],0); -ELEMENTS[40864] = Fluid3D([11741,12335,12639,11965],0); -ELEMENTS[40865] = Fluid3D([12335,12639,11965,12478],0); -ELEMENTS[40866] = Fluid3D([12639,11741,11965,12100],0); -ELEMENTS[40867] = Fluid3D([12639,11741,12100,11879],0); -ELEMENTS[40868] = Fluid3D([11965,12639,12100,13036],0); -ELEMENTS[40869] = Fluid3D([11741,12100,11879,11089],0); -ELEMENTS[40870] = Fluid3D([12639,11741,11879,12247],0); -ELEMENTS[40871] = Fluid3D([11741,11965,12100,11498],0); -ELEMENTS[40872] = Fluid3D([11965,12100,11498,11997],0); -ELEMENTS[40873] = Fluid3D([6571,7166,6676,7320],0); -ELEMENTS[40874] = Fluid3D([6531,7043,7495,6637],0); -ELEMENTS[40875] = Fluid3D([6531,7043,6637,6270],0); -ELEMENTS[40876] = Fluid3D([6637,6531,6270,6084],0); -ELEMENTS[40877] = Fluid3D([6270,6637,6084,6375],0); -ELEMENTS[40878] = Fluid3D([7043,6637,6270,6745],0); -ELEMENTS[40879] = Fluid3D([6270,6637,6375,6745],0); -ELEMENTS[40880] = Fluid3D([6637,6531,6084,7059],0); -ELEMENTS[40881] = Fluid3D([3965,3549,3848,3464],0); -ELEMENTS[40882] = Fluid3D([10479,10118,10932,9962],0); -ELEMENTS[40883] = Fluid3D([15075,15022,14445,14469],0); -ELEMENTS[40884] = Fluid3D([7192,7903,6999,7343],0); -ELEMENTS[40885] = Fluid3D([6999,7192,7343,6744],0); -ELEMENTS[40886] = Fluid3D([7343,6999,6744,7355],0); -ELEMENTS[40887] = Fluid3D([6999,6744,7355,6627],0); -ELEMENTS[40888] = Fluid3D([6744,7343,7355,6696],0); -ELEMENTS[40889] = Fluid3D([6744,7343,6696,7192],0); -ELEMENTS[40890] = Fluid3D([7343,6999,7355,7903],0); -ELEMENTS[40891] = Fluid3D([6999,7192,6744,6282],0); -ELEMENTS[40892] = Fluid3D([6744,6999,6282,6206],0); -ELEMENTS[40893] = Fluid3D([6744,6999,6206,6627],0); -ELEMENTS[40894] = Fluid3D([7192,7903,7343,7690],0); -ELEMENTS[40895] = Fluid3D([17607,17622,17267,17616],0); -ELEMENTS[40896] = Fluid3D([6710,7532,7023,7053],0); -ELEMENTS[40897] = Fluid3D([7285,7979,8097,8333],0); -ELEMENTS[40898] = Fluid3D([5269,5060,4743,4691],0); -ELEMENTS[40899] = Fluid3D([11778,12384,12465,11432],0); -ELEMENTS[40900] = Fluid3D([11778,12384,11432,11776],0); -ELEMENTS[40901] = Fluid3D([10120,9366,9661,9089],0); -ELEMENTS[40902] = Fluid3D([14387,14196,13933,14369],0); -ELEMENTS[40903] = Fluid3D([14196,13933,14369,13614],0); -ELEMENTS[40904] = Fluid3D([13933,14369,13614,13790],0); -ELEMENTS[40905] = Fluid3D([13933,14369,13790,13836],0); -ELEMENTS[40906] = Fluid3D([13933,14387,14369,14870],0); -ELEMENTS[40907] = Fluid3D([14369,13933,14870,13836],0); -ELEMENTS[40908] = Fluid3D([9337,9569,9505,8641],0); -ELEMENTS[40909] = Fluid3D([13174,12777,12111,12414],0); -ELEMENTS[40910] = Fluid3D([12609,12477,12816,11622],0); -ELEMENTS[40911] = Fluid3D([13829,13305,13274,13951],0); -ELEMENTS[40912] = Fluid3D([13629,14117,14453,14446],0); -ELEMENTS[40913] = Fluid3D([10209,10023,9610,9240],0); -ELEMENTS[40914] = Fluid3D([10209,10023,9240,9096],0); -ELEMENTS[40915] = Fluid3D([3888,4083,4320,4081],0); -ELEMENTS[40916] = Fluid3D([4343,4202,3768,3940],0); -ELEMENTS[40917] = Fluid3D([3768,4343,3940,4025],0); -ELEMENTS[40918] = Fluid3D([4343,3940,4025,4429],0); -ELEMENTS[40919] = Fluid3D([4343,4202,3940,4295],0); -ELEMENTS[40920] = Fluid3D([3940,4343,4295,4429],0); -ELEMENTS[40921] = Fluid3D([3027,3108,3222,2746],0); -ELEMENTS[40922] = Fluid3D([13940,14553,14441,14834],0); -ELEMENTS[40923] = Fluid3D([8295,7775,7467,7981],0); -ELEMENTS[40924] = Fluid3D([9448,9574,9451,8742],0); -ELEMENTS[40925] = Fluid3D([13199,12207,12978,12629],0); -ELEMENTS[40926] = Fluid3D([17186,17499,17477,17179],0); -ELEMENTS[40927] = Fluid3D([17186,17499,17179,16866],0); -ELEMENTS[40928] = Fluid3D([17499,17477,17179,17575],0); -ELEMENTS[40929] = Fluid3D([2792,3056,3248,2930],0); -ELEMENTS[40930] = Fluid3D([10898,11259,11406,12010],0); -ELEMENTS[40931] = Fluid3D([7223,7897,7106,7113],0); -ELEMENTS[40932] = Fluid3D([8058,7367,7627,8374],0); -ELEMENTS[40933] = Fluid3D([11856,11277,12178,11212],0); -ELEMENTS[40934] = Fluid3D([16596,16870,16620,16780],0); -ELEMENTS[40935] = Fluid3D([14840,14583,14211,15190],0); -ELEMENTS[40936] = Fluid3D([4898,4500,4531,5268],0); -ELEMENTS[40937] = Fluid3D([13675,13329,13150,14282],0); -ELEMENTS[40938] = Fluid3D([18276,18480,18431,18510],0); -ELEMENTS[40939] = Fluid3D([16270,16723,16407,16671],0); -ELEMENTS[40940] = Fluid3D([16407,16270,16671,16335],0); -ELEMENTS[40941] = Fluid3D([16270,16671,16335,16802],0); -ELEMENTS[40942] = Fluid3D([16671,16335,16802,16891],0); -ELEMENTS[40943] = Fluid3D([16802,16671,16891,16723],0); -ELEMENTS[40944] = Fluid3D([16671,16335,16891,16396],0); -ELEMENTS[40945] = Fluid3D([16270,16723,16671,16802],0); -ELEMENTS[40946] = Fluid3D([16891,16671,16396,16751],0); -ELEMENTS[40947] = Fluid3D([16891,16671,16751,16723],0); -ELEMENTS[40948] = Fluid3D([14023,14246,14872,14696],0); -ELEMENTS[40949] = Fluid3D([9408,9107,9510,9982],0); -ELEMENTS[40950] = Fluid3D([17433,17114,17168,17296],0); -ELEMENTS[40951] = Fluid3D([4978,5525,5261,5684],0); -ELEMENTS[40952] = Fluid3D([8438,8906,9534,8898],0); -ELEMENTS[40953] = Fluid3D([9534,8438,8898,9202],0); -ELEMENTS[40954] = Fluid3D([8438,8906,8898,7919],0); -ELEMENTS[40955] = Fluid3D([12062,12428,13052,12977],0); -ELEMENTS[40956] = Fluid3D([12428,13052,12977,13718],0); -ELEMENTS[40957] = Fluid3D([5699,6008,6263,6152],0); -ELEMENTS[40958] = Fluid3D([5916,6543,6009,6321],0); -ELEMENTS[40959] = Fluid3D([11441,11612,12350,11860],0); -ELEMENTS[40960] = Fluid3D([8494,9107,9421,8976],0); -ELEMENTS[40961] = Fluid3D([5207,5028,4653,5319],0); -ELEMENTS[40962] = Fluid3D([17908,17944,17786,18123],0); -ELEMENTS[40963] = Fluid3D([9358,8850,8694,9548],0); -ELEMENTS[40964] = Fluid3D([8694,9358,9548,9699],0); -ELEMENTS[40965] = Fluid3D([9358,9548,9699,10093],0); -ELEMENTS[40966] = Fluid3D([9548,9699,10093,9895],0); -ELEMENTS[40967] = Fluid3D([9548,9699,9895,9095],0); -ELEMENTS[40968] = Fluid3D([9895,9548,9095,10093],0); -ELEMENTS[40969] = Fluid3D([9548,9095,10093,8850],0); -ELEMENTS[40970] = Fluid3D([9548,8694,9699,9095],0); -ELEMENTS[40971] = Fluid3D([9548,8694,9095,8850],0); -ELEMENTS[40972] = Fluid3D([8694,9358,9699,9321],0); -ELEMENTS[40973] = Fluid3D([9358,8850,9548,10093],0); -ELEMENTS[40974] = Fluid3D([12280,11406,11884,11172],0); -ELEMENTS[40975] = Fluid3D([12249,11653,11310,11492],0); -ELEMENTS[40976] = Fluid3D([13895,14320,14109,13474],0); -ELEMENTS[40977] = Fluid3D([10113,9382,10072,10475],0); -ELEMENTS[40978] = Fluid3D([16094,16386,15876,16436],0); -ELEMENTS[40979] = Fluid3D([6298,6047,6086,5555],0); -ELEMENTS[40980] = Fluid3D([9690,9636,10566,10404],0); -ELEMENTS[40981] = Fluid3D([7862,7395,7126,7299],0); -ELEMENTS[40982] = Fluid3D([12612,12591,13027,12394],0); -ELEMENTS[40983] = Fluid3D([13027,12612,12394,13691],0); -ELEMENTS[40984] = Fluid3D([2528,2743,2771,2578],0); -ELEMENTS[40985] = Fluid3D([2771,2528,2578,2433],0); -ELEMENTS[40986] = Fluid3D([2528,2743,2578,2350],0); -ELEMENTS[40987] = Fluid3D([11071,11219,11664,10570],0); -ELEMENTS[40988] = Fluid3D([11071,11219,10570,10258],0); -ELEMENTS[40989] = Fluid3D([10570,11071,10258,10978],0); -ELEMENTS[40990] = Fluid3D([11664,11071,10570,10978],0); -ELEMENTS[40991] = Fluid3D([6944,6362,6809,5953],0); -ELEMENTS[40992] = Fluid3D([17204,16787,16859,16810],0); -ELEMENTS[40993] = Fluid3D([5038,4816,5328,5014],0); -ELEMENTS[40994] = Fluid3D([10757,10055,11188,10472],0); -ELEMENTS[40995] = Fluid3D([15017,14513,14277,14751],0); -ELEMENTS[40996] = Fluid3D([14277,15017,14751,14941],0); -ELEMENTS[40997] = Fluid3D([15017,14513,14751,15283],0); -ELEMENTS[40998] = Fluid3D([3582,3846,4026,4000],0); -ELEMENTS[40999] = Fluid3D([6001,6763,6571,6149],0); -ELEMENTS[41000] = Fluid3D([7512,7193,6861,6438],0); -ELEMENTS[41001] = Fluid3D([7110,7806,7608,6779],0); -ELEMENTS[41002] = Fluid3D([15478,15269,14849,15586],0); -ELEMENTS[41003] = Fluid3D([6878,7241,7487,7505],0); -ELEMENTS[41004] = Fluid3D([7487,6878,7505,6970],0); -ELEMENTS[41005] = Fluid3D([6878,7505,6970,6812],0); -ELEMENTS[41006] = Fluid3D([7487,6878,6970,6741],0); -ELEMENTS[41007] = Fluid3D([6878,6970,6741,6236],0); -ELEMENTS[41008] = Fluid3D([6970,6741,6236,6468],0); -ELEMENTS[41009] = Fluid3D([6970,7487,6741,7888],0); -ELEMENTS[41010] = Fluid3D([7505,7487,6970,7991],0); -ELEMENTS[41011] = Fluid3D([6970,6878,6812,6236],0); -ELEMENTS[41012] = Fluid3D([6878,7241,7505,7421],0); -ELEMENTS[41013] = Fluid3D([7505,6878,7421,6794],0); -ELEMENTS[41014] = Fluid3D([6970,7505,7991,6812],0); -ELEMENTS[41015] = Fluid3D([2352,2272,2532,2318],0); -ELEMENTS[41016] = Fluid3D([12450,11922,11548,12469],0); -ELEMENTS[41017] = Fluid3D([12450,11922,12469,13072],0); -ELEMENTS[41018] = Fluid3D([12531,12129,12981,12149],0); -ELEMENTS[41019] = Fluid3D([11455,11553,11691,12115],0); -ELEMENTS[41020] = Fluid3D([11455,11553,12115,11644],0); -ELEMENTS[41021] = Fluid3D([11553,12115,11644,12171],0); -ELEMENTS[41022] = Fluid3D([11553,11691,12115,12529],0); -ELEMENTS[41023] = Fluid3D([12115,11553,12529,12171],0); -ELEMENTS[41024] = Fluid3D([11691,11455,12115,12574],0); -ELEMENTS[41025] = Fluid3D([11691,12115,12529,12574],0); -ELEMENTS[41026] = Fluid3D([16792,16808,16205,16849],0); -ELEMENTS[41027] = Fluid3D([11228,10249,10844,11509],0); -ELEMENTS[41028] = Fluid3D([12667,12155,11701,12153],0); -ELEMENTS[41029] = Fluid3D([10633,10925,10006,11152],0); -ELEMENTS[41030] = Fluid3D([14082,14775,14043,14920],0); -ELEMENTS[41031] = Fluid3D([15083,14493,14796,15539],0); -ELEMENTS[41032] = Fluid3D([7293,8062,8469,7545],0); -ELEMENTS[41033] = Fluid3D([14580,15331,14885,15265],0); -ELEMENTS[41034] = Fluid3D([14580,15331,15265,15065],0); -ELEMENTS[41035] = Fluid3D([15331,14885,15265,15451],0); -ELEMENTS[41036] = Fluid3D([15265,15331,15451,15901],0); -ELEMENTS[41037] = Fluid3D([15265,15331,15901,15732],0); -ELEMENTS[41038] = Fluid3D([15265,15331,15732,15065],0); -ELEMENTS[41039] = Fluid3D([15331,15901,15732,15639],0); -ELEMENTS[41040] = Fluid3D([3304,2995,3122,3334],0); -ELEMENTS[41041] = Fluid3D([3542,3599,3864,4009],0); -ELEMENTS[41042] = Fluid3D([4907,5048,4591,5120],0); -ELEMENTS[41043] = Fluid3D([9224,10194,9549,10219],0); -ELEMENTS[41044] = Fluid3D([9549,9224,10219,9296],0); -ELEMENTS[41045] = Fluid3D([9224,10219,9296,10587],0); -ELEMENTS[41046] = Fluid3D([9549,9224,9296,8623],0); -ELEMENTS[41047] = Fluid3D([9224,10194,10219,10587],0); -ELEMENTS[41048] = Fluid3D([10219,9549,9296,9986],0); -ELEMENTS[41049] = Fluid3D([9296,10219,9986,10390],0); -ELEMENTS[41050] = Fluid3D([9549,9296,9986,9295],0); -ELEMENTS[41051] = Fluid3D([9296,9986,9295,10390],0); -ELEMENTS[41052] = Fluid3D([9986,9295,10390,9812],0); -ELEMENTS[41053] = Fluid3D([10219,9549,9986,11073],0); -ELEMENTS[41054] = Fluid3D([10219,9986,10390,10954],0); -ELEMENTS[41055] = Fluid3D([9986,10390,10954,10716],0); -ELEMENTS[41056] = Fluid3D([10954,9986,10716,10543],0); -ELEMENTS[41057] = Fluid3D([10954,9986,10543,11073],0); -ELEMENTS[41058] = Fluid3D([10543,10954,11073,11671],0); -ELEMENTS[41059] = Fluid3D([11073,10543,11671,11000],0); -ELEMENTS[41060] = Fluid3D([10716,10954,10543,11797],0); -ELEMENTS[41061] = Fluid3D([10219,9986,10954,11073],0); -ELEMENTS[41062] = Fluid3D([9986,10716,10543,9812],0); -ELEMENTS[41063] = Fluid3D([9986,10390,10716,9812],0); -ELEMENTS[41064] = Fluid3D([5700,5420,6103,5999],0); -ELEMENTS[41065] = Fluid3D([5420,6103,5999,5819],0); -ELEMENTS[41066] = Fluid3D([6103,5700,5999,6348],0); -ELEMENTS[41067] = Fluid3D([5999,5420,5819,5242],0); -ELEMENTS[41068] = Fluid3D([6103,5999,5819,6729],0); -ELEMENTS[41069] = Fluid3D([5999,6103,6348,6818],0); -ELEMENTS[41070] = Fluid3D([5999,6103,6818,6729],0); -ELEMENTS[41071] = Fluid3D([5700,5420,5999,5658],0); -ELEMENTS[41072] = Fluid3D([3985,4009,4368,3990],0); -ELEMENTS[41073] = Fluid3D([3985,4009,3990,3492],0); -ELEMENTS[41074] = Fluid3D([4368,3985,3990,3879],0); -ELEMENTS[41075] = Fluid3D([14539,15156,14528,15164],0); -ELEMENTS[41076] = Fluid3D([9914,8968,9741,9321],0); -ELEMENTS[41077] = Fluid3D([12455,13256,12690,12706],0); -ELEMENTS[41078] = Fluid3D([15974,16349,16557,16565],0); -ELEMENTS[41079] = Fluid3D([2640,2665,2469,2414],0); -ELEMENTS[41080] = Fluid3D([2639,2779,2440,2527],0); -ELEMENTS[41081] = Fluid3D([9655,10109,9535,8721],0); -ELEMENTS[41082] = Fluid3D([14339,14720,14261,14995],0); -ELEMENTS[41083] = Fluid3D([9668,8763,9334,9428],0); -ELEMENTS[41084] = Fluid3D([15146,14516,14592,14180],0); -ELEMENTS[41085] = Fluid3D([9340,9148,9628,8674],0); -ELEMENTS[41086] = Fluid3D([9340,9148,8674,8765],0); -ELEMENTS[41087] = Fluid3D([9628,9340,8674,8677],0); -ELEMENTS[41088] = Fluid3D([8674,9340,8765,8677],0); -ELEMENTS[41089] = Fluid3D([9340,8765,8677,9530],0); -ELEMENTS[41090] = Fluid3D([9340,8765,9530,9617],0); -ELEMENTS[41091] = Fluid3D([10724,11710,11413,11483],0); -ELEMENTS[41092] = Fluid3D([3506,3719,3677,3206],0); -ELEMENTS[41093] = Fluid3D([10861,11212,11317,11764],0); -ELEMENTS[41094] = Fluid3D([13041,12351,12783,13040],0); -ELEMENTS[41095] = Fluid3D([8136,8947,8291,7712],0); -ELEMENTS[41096] = Fluid3D([13270,12661,12427,12419],0); -ELEMENTS[41097] = Fluid3D([3479,3145,2938,3071],0); -ELEMENTS[41098] = Fluid3D([3145,2938,3071,2689],0); -ELEMENTS[41099] = Fluid3D([4330,3899,4348,3995],0); -ELEMENTS[41100] = Fluid3D([17059,17224,16790,16712],0); -ELEMENTS[41101] = Fluid3D([12782,13409,12570,12617],0); -ELEMENTS[41102] = Fluid3D([15191,15365,15725,15995],0); -ELEMENTS[41103] = Fluid3D([12906,13449,13883,13736],0); -ELEMENTS[41104] = Fluid3D([14625,14820,15364,15385],0); -ELEMENTS[41105] = Fluid3D([6613,6023,5913,6345],0); -ELEMENTS[41106] = Fluid3D([6023,5913,6345,5546],0); -ELEMENTS[41107] = Fluid3D([6613,6023,6345,6646],0); -ELEMENTS[41108] = Fluid3D([13773,14025,14355,13766],0); -ELEMENTS[41109] = Fluid3D([13773,14025,13766,12767],0); -ELEMENTS[41110] = Fluid3D([4794,4943,4930,5535],0); -ELEMENTS[41111] = Fluid3D([16707,16843,17159,17012],0); -ELEMENTS[41112] = Fluid3D([18224,18269,18102,17958],0); -ELEMENTS[41113] = Fluid3D([3237,3622,3133,3462],0); -ELEMENTS[41114] = Fluid3D([18036,17746,17993,17806],0); -ELEMENTS[41115] = Fluid3D([5796,5565,5447,5215],0); -ELEMENTS[41116] = Fluid3D([5796,5565,5215,5754],0); -ELEMENTS[41117] = Fluid3D([5923,5673,6446,5855],0); -ELEMENTS[41118] = Fluid3D([8300,8522,8809,9228],0); -ELEMENTS[41119] = Fluid3D([9260,8342,9069,8811],0); -ELEMENTS[41120] = Fluid3D([9260,8342,8811,8635],0); -ELEMENTS[41121] = Fluid3D([9069,9260,8811,9973],0); -ELEMENTS[41122] = Fluid3D([11002,10623,10074,11363],0); -ELEMENTS[41123] = Fluid3D([10369,10898,11393,11442],0); -ELEMENTS[41124] = Fluid3D([18240,18444,18414,18431],0); -ELEMENTS[41125] = Fluid3D([18414,18240,18431,18287],0); -ELEMENTS[41126] = Fluid3D([18240,18444,18431,18405],0); -ELEMENTS[41127] = Fluid3D([18431,18240,18405,18276],0); -ELEMENTS[41128] = Fluid3D([7587,7375,6729,7422],0); -ELEMENTS[41129] = Fluid3D([7965,7889,7418,8648],0); -ELEMENTS[41130] = Fluid3D([12656,12881,12675,11387],0); -ELEMENTS[41131] = Fluid3D([13308,13652,14169,13633],0); -ELEMENTS[41132] = Fluid3D([9110,9677,9714,10104],0); -ELEMENTS[41133] = Fluid3D([9714,9110,10104,9374],0); -ELEMENTS[41134] = Fluid3D([9677,9714,10104,10493],0); -ELEMENTS[41135] = Fluid3D([9714,10104,10493,10496],0); -ELEMENTS[41136] = Fluid3D([9714,10104,10496,10361],0); -ELEMENTS[41137] = Fluid3D([10104,10496,10361,11148],0); -ELEMENTS[41138] = Fluid3D([10496,10361,11148,11070],0); -ELEMENTS[41139] = Fluid3D([11148,10496,11070,10442],0); -ELEMENTS[41140] = Fluid3D([9714,10104,10361,9374],0); -ELEMENTS[41141] = Fluid3D([10496,9714,10361,10210],0); -ELEMENTS[41142] = Fluid3D([10496,9714,10210,10806],0); -ELEMENTS[41143] = Fluid3D([10210,10496,10806,11148],0); -ELEMENTS[41144] = Fluid3D([10496,10806,11148,10493],0); -ELEMENTS[41145] = Fluid3D([10210,10496,11148,10442],0); -ELEMENTS[41146] = Fluid3D([10210,10496,10442,10361],0); -ELEMENTS[41147] = Fluid3D([10493,9714,10496,9853],0); -ELEMENTS[41148] = Fluid3D([10493,9714,9853,9677],0); -ELEMENTS[41149] = Fluid3D([10104,10493,10496,11148],0); -ELEMENTS[41150] = Fluid3D([10496,10361,11070,10442],0); -ELEMENTS[41151] = Fluid3D([10496,10806,10493,9853],0); -ELEMENTS[41152] = Fluid3D([10806,10210,11148,11481],0); -ELEMENTS[41153] = Fluid3D([10806,10493,9853,11411],0); -ELEMENTS[41154] = Fluid3D([3440,3313,3036,3009],0); -ELEMENTS[41155] = Fluid3D([15787,16295,16106,16371],0); -ELEMENTS[41156] = Fluid3D([8369,8633,8331,9338],0); -ELEMENTS[41157] = Fluid3D([17875,17752,17532,17587],0); -ELEMENTS[41158] = Fluid3D([16734,16333,16218,16715],0); -ELEMENTS[41159] = Fluid3D([15204,15628,15099,15369],0); -ELEMENTS[41160] = Fluid3D([5879,5311,5777,5965],0); -ELEMENTS[41161] = Fluid3D([4830,4783,4352,4912],0); -ELEMENTS[41162] = Fluid3D([6196,6140,6982,6116],0); -ELEMENTS[41163] = Fluid3D([17470,17217,17014,17469],0); -ELEMENTS[41164] = Fluid3D([16122,16518,16583,16445],0); -ELEMENTS[41165] = Fluid3D([8789,8859,8593,8029],0); -ELEMENTS[41166] = Fluid3D([13194,13244,12519,13749],0); -ELEMENTS[41167] = Fluid3D([12958,13392,12466,12519],0); -ELEMENTS[41168] = Fluid3D([3229,3263,3471,3120],0); -ELEMENTS[41169] = Fluid3D([11791,11328,11692,12382],0); -ELEMENTS[41170] = Fluid3D([17626,17464,17275,17154],0); -ELEMENTS[41171] = Fluid3D([7413,8013,8483,8342],0); -ELEMENTS[41172] = Fluid3D([7413,8013,8342,8396],0); -ELEMENTS[41173] = Fluid3D([9157,8360,8687,9352],0); -ELEMENTS[41174] = Fluid3D([6950,7856,7181,7745],0); -ELEMENTS[41175] = Fluid3D([12660,12237,12469,11656],0); -ELEMENTS[41176] = Fluid3D([14685,15108,14721,14697],0); -ELEMENTS[41177] = Fluid3D([15108,14721,14697,15092],0); -ELEMENTS[41178] = Fluid3D([12827,11882,12557,12272],0); -ELEMENTS[41179] = Fluid3D([11882,12557,12272,12256],0); -ELEMENTS[41180] = Fluid3D([12557,12272,12256,12617],0); -ELEMENTS[41181] = Fluid3D([12272,12256,12617,11809],0); -ELEMENTS[41182] = Fluid3D([12272,12256,11809,11882],0); -ELEMENTS[41183] = Fluid3D([12617,12272,11809,12827],0); -ELEMENTS[41184] = Fluid3D([11809,12272,11882,12827],0); -ELEMENTS[41185] = Fluid3D([12617,12272,12827,12557],0); -ELEMENTS[41186] = Fluid3D([12256,12617,11809,11289],0); -ELEMENTS[41187] = Fluid3D([11809,12256,11289,11223],0); -ELEMENTS[41188] = Fluid3D([11289,11809,11223,11022],0); -ELEMENTS[41189] = Fluid3D([11809,12256,11223,11566],0); -ELEMENTS[41190] = Fluid3D([11809,12256,11566,11882],0); -ELEMENTS[41191] = Fluid3D([12256,11223,11566,11722],0); -ELEMENTS[41192] = Fluid3D([12256,11289,11223,11787],0); -ELEMENTS[41193] = Fluid3D([11223,12256,11787,11722],0); -ELEMENTS[41194] = Fluid3D([11787,11223,11722,10984],0); -ELEMENTS[41195] = Fluid3D([11289,11223,11787,10349],0); -ELEMENTS[41196] = Fluid3D([11289,11809,11022,11040],0); -ELEMENTS[41197] = Fluid3D([11289,11809,11040,11984],0); -ELEMENTS[41198] = Fluid3D([11040,11289,11984,10939],0); -ELEMENTS[41199] = Fluid3D([12617,11809,11289,11984],0); -ELEMENTS[41200] = Fluid3D([11022,11289,11040,10208],0); -ELEMENTS[41201] = Fluid3D([11809,12617,12827,11984],0); -ELEMENTS[41202] = Fluid3D([11289,11040,10208,10335],0); -ELEMENTS[41203] = Fluid3D([16203,16316,16174,15695],0); -ELEMENTS[41204] = Fluid3D([4545,4304,4592,4356],0); -ELEMENTS[41205] = Fluid3D([4592,4545,4356,5100],0); -ELEMENTS[41206] = Fluid3D([2346,2516,2518,2211],0); -ELEMENTS[41207] = Fluid3D([2346,2516,2211,2312],0); -ELEMENTS[41208] = Fluid3D([12540,12026,12429,12464],0); -ELEMENTS[41209] = Fluid3D([15523,15035,15390,15024],0); -ELEMENTS[41210] = Fluid3D([8018,8533,8957,7723],0); -ELEMENTS[41211] = Fluid3D([8018,8533,7723,7340],0); -ELEMENTS[41212] = Fluid3D([7723,8018,7340,7299],0); -ELEMENTS[41213] = Fluid3D([8018,7340,7299,7711],0); -ELEMENTS[41214] = Fluid3D([8018,8533,7340,7711],0); -ELEMENTS[41215] = Fluid3D([6763,6934,7595,7315],0); -ELEMENTS[41216] = Fluid3D([11110,11965,11274,11512],0); -ELEMENTS[41217] = Fluid3D([11965,11274,11512,12478],0); -ELEMENTS[41218] = Fluid3D([11274,11110,11512,10255],0); -ELEMENTS[41219] = Fluid3D([11110,11965,11512,11248],0); -ELEMENTS[41220] = Fluid3D([11965,11512,11248,11741],0); -ELEMENTS[41221] = Fluid3D([11248,11965,11741,11498],0); -ELEMENTS[41222] = Fluid3D([11248,11965,11498,11110],0); -ELEMENTS[41223] = Fluid3D([11512,11248,11741,10708],0); -ELEMENTS[41224] = Fluid3D([11248,11741,10708,10529],0); -ELEMENTS[41225] = Fluid3D([10708,11248,10529,11110],0); -ELEMENTS[41226] = Fluid3D([11248,11741,10529,11089],0); -ELEMENTS[41227] = Fluid3D([11512,11248,10708,11110],0); -ELEMENTS[41228] = Fluid3D([11498,11248,11110,10529],0); -ELEMENTS[41229] = Fluid3D([11498,11248,10529,11089],0); -ELEMENTS[41230] = Fluid3D([11512,11274,10255,10781],0); -ELEMENTS[41231] = Fluid3D([11512,11274,10781,11452],0); -ELEMENTS[41232] = Fluid3D([11512,11274,11452,12478],0); -ELEMENTS[41233] = Fluid3D([8256,8776,7839,7950],0); -ELEMENTS[41234] = Fluid3D([3725,4100,3591,3830],0); -ELEMENTS[41235] = Fluid3D([10130,9214,9958,9923],0); -ELEMENTS[41236] = Fluid3D([10516,9859,9437,10074],0); -ELEMENTS[41237] = Fluid3D([17949,17877,18103,18247],0); -ELEMENTS[41238] = Fluid3D([6792,7308,7290,6794],0); -ELEMENTS[41239] = Fluid3D([5674,6094,6150,6653],0); -ELEMENTS[41240] = Fluid3D([13973,13854,13840,14627],0); -ELEMENTS[41241] = Fluid3D([17734,17535,17920,17739],0); -ELEMENTS[41242] = Fluid3D([8023,8657,8518,9285],0); -ELEMENTS[41243] = Fluid3D([17539,17170,17345,17212],0); -ELEMENTS[41244] = Fluid3D([10800,11478,10580,11395],0); -ELEMENTS[41245] = Fluid3D([14860,14238,13914,14822],0); -ELEMENTS[41246] = Fluid3D([9463,9680,9015,9009],0); -ELEMENTS[41247] = Fluid3D([15121,14401,14446,14568],0); -ELEMENTS[41248] = Fluid3D([14401,14446,14568,14117],0); -ELEMENTS[41249] = Fluid3D([15121,14401,14568,14574],0); -ELEMENTS[41250] = Fluid3D([5251,5810,5277,5124],0); -ELEMENTS[41251] = Fluid3D([15354,15553,15670,16175],0); -ELEMENTS[41252] = Fluid3D([15553,15670,16175,16106],0); -ELEMENTS[41253] = Fluid3D([2427,2250,2410,2620],0); -ELEMENTS[41254] = Fluid3D([5769,5602,5187,5615],0); -ELEMENTS[41255] = Fluid3D([3140,3499,3576,3458],0); -ELEMENTS[41256] = Fluid3D([13773,14206,13870,13530],0); -ELEMENTS[41257] = Fluid3D([4445,4514,4029,4306],0); -ELEMENTS[41258] = Fluid3D([4445,4514,4306,4757],0); -ELEMENTS[41259] = Fluid3D([4306,4445,4757,4957],0); -ELEMENTS[41260] = Fluid3D([4029,4445,4306,4092],0); -ELEMENTS[41261] = Fluid3D([12352,12247,13100,12573],0); -ELEMENTS[41262] = Fluid3D([11576,12147,12088,12507],0); -ELEMENTS[41263] = Fluid3D([7265,7690,6696,6709],0); -ELEMENTS[41264] = Fluid3D([1808,1888,1966,1807],0); -ELEMENTS[41265] = Fluid3D([1808,1888,1807,1727],0); -ELEMENTS[41266] = Fluid3D([1888,1966,1807,1972],0); -ELEMENTS[41267] = Fluid3D([2206,2116,2410,2250],0); -ELEMENTS[41268] = Fluid3D([11053,10768,11124,11908],0); -ELEMENTS[41269] = Fluid3D([15410,15838,15275,15881],0); -ELEMENTS[41270] = Fluid3D([9148,10085,9628,10414],0); -ELEMENTS[41271] = Fluid3D([16772,17051,17120,16465],0); -ELEMENTS[41272] = Fluid3D([17089,16769,17229,17286],0); -ELEMENTS[41273] = Fluid3D([11549,11038,10580,11232],0); -ELEMENTS[41274] = Fluid3D([11549,11038,11232,11554],0); -ELEMENTS[41275] = Fluid3D([8069,8198,8096,7316],0); -ELEMENTS[41276] = Fluid3D([12320,11764,12182,11212],0); -ELEMENTS[41277] = Fluid3D([7600,7899,8094,8467],0); -ELEMENTS[41278] = Fluid3D([7899,8094,8467,9200],0); -ELEMENTS[41279] = Fluid3D([7600,7899,8467,8405],0); -ELEMENTS[41280] = Fluid3D([7899,8467,8405,8881],0); -ELEMENTS[41281] = Fluid3D([7899,8467,8881,9200],0); -ELEMENTS[41282] = Fluid3D([8467,7600,8405,7721],0); -ELEMENTS[41283] = Fluid3D([8405,8467,7721,8410],0); -ELEMENTS[41284] = Fluid3D([8405,8467,8410,9084],0); -ELEMENTS[41285] = Fluid3D([8467,7721,8410,8231],0); -ELEMENTS[41286] = Fluid3D([8405,8467,9084,9355],0); -ELEMENTS[41287] = Fluid3D([8467,8410,9084,8231],0); -ELEMENTS[41288] = Fluid3D([7721,8405,8410,8114],0); -ELEMENTS[41289] = Fluid3D([8467,7600,7721,8231],0); -ELEMENTS[41290] = Fluid3D([7721,8410,8231,8452],0); -ELEMENTS[41291] = Fluid3D([13089,13745,12920,12847],0); -ELEMENTS[41292] = Fluid3D([11009,10592,11104,11603],0); -ELEMENTS[41293] = Fluid3D([14632,15125,14458,15334],0); -ELEMENTS[41294] = Fluid3D([15125,14458,15334,15666],0); -ELEMENTS[41295] = Fluid3D([15125,14458,15666,14886],0); -ELEMENTS[41296] = Fluid3D([15125,14458,14886,14611],0); -ELEMENTS[41297] = Fluid3D([2820,3147,2932,2721],0); -ELEMENTS[41298] = Fluid3D([9613,8929,9062,9582],0); -ELEMENTS[41299] = Fluid3D([8929,9062,9582,8469],0); -ELEMENTS[41300] = Fluid3D([9613,8929,9582,10254],0); -ELEMENTS[41301] = Fluid3D([9582,9613,10254,10207],0); -ELEMENTS[41302] = Fluid3D([14162,14566,15088,14768],0); -ELEMENTS[41303] = Fluid3D([11575,12059,11196,12624],0); -ELEMENTS[41304] = Fluid3D([10383,10212,9448,9596],0); -ELEMENTS[41305] = Fluid3D([9448,10383,9596,9327],0); -ELEMENTS[41306] = Fluid3D([9182,9773,9780,8737],0); -ELEMENTS[41307] = Fluid3D([13407,13564,12883,12670],0); -ELEMENTS[41308] = Fluid3D([17024,16565,16866,16743],0); -ELEMENTS[41309] = Fluid3D([3205,3164,3433,2878],0); -ELEMENTS[41310] = Fluid3D([4339,4608,4288,4992],0); -ELEMENTS[41311] = Fluid3D([7158,7854,8089,8042],0); -ELEMENTS[41312] = Fluid3D([5750,6072,6312,6645],0); -ELEMENTS[41313] = Fluid3D([16271,16635,16691,16214],0); -ELEMENTS[41314] = Fluid3D([12385,13231,12948,12561],0); -ELEMENTS[41315] = Fluid3D([16931,16886,17188,17377],0); -ELEMENTS[41316] = Fluid3D([9482,10349,9581,10317],0); -ELEMENTS[41317] = Fluid3D([8300,7858,7731,8622],0); -ELEMENTS[41318] = Fluid3D([11974,11380,12359,11546],0); -ELEMENTS[41319] = Fluid3D([6334,6024,5751,5658],0); -ELEMENTS[41320] = Fluid3D([14029,13848,13113,13612],0); -ELEMENTS[41321] = Fluid3D([15072,14959,14908,14764],0); -ELEMENTS[41322] = Fluid3D([9552,10043,10527,10268],0); -ELEMENTS[41323] = Fluid3D([9064,8438,9202,8372],0); -ELEMENTS[41324] = Fluid3D([10887,10889,11630,11966],0); -ELEMENTS[41325] = Fluid3D([6488,5915,6321,5857],0); -ELEMENTS[41326] = Fluid3D([14093,13818,13969,13085],0); -ELEMENTS[41327] = Fluid3D([8548,9004,8230,8995],0); -ELEMENTS[41328] = Fluid3D([5675,6021,6393,5978],0); -ELEMENTS[41329] = Fluid3D([16576,16213,16030,16155],0); -ELEMENTS[41330] = Fluid3D([9529,9481,9358,10119],0); -ELEMENTS[41331] = Fluid3D([18281,18216,18042,18202],0); -ELEMENTS[41332] = Fluid3D([11492,12229,11653,11358],0); -ELEMENTS[41333] = Fluid3D([12229,11653,11358,12103],0); -ELEMENTS[41334] = Fluid3D([11653,11358,12103,11205],0); -ELEMENTS[41335] = Fluid3D([17067,17504,17369,17421],0); -ELEMENTS[41336] = Fluid3D([17504,17369,17421,17822],0); -ELEMENTS[41337] = Fluid3D([9925,10811,9969,10009],0); -ELEMENTS[41338] = Fluid3D([9925,10811,10009,10478],0); -ELEMENTS[41339] = Fluid3D([10009,9925,10478,9641],0); -ELEMENTS[41340] = Fluid3D([15231,15258,14946,14515],0); -ELEMENTS[41341] = Fluid3D([10056,9802,10895,10514],0); -ELEMENTS[41342] = Fluid3D([8430,9377,8845,9179],0); -ELEMENTS[41343] = Fluid3D([11839,12614,12818,13043],0); -ELEMENTS[41344] = Fluid3D([4777,5211,5304,5046],0); -ELEMENTS[41345] = Fluid3D([12118,12920,12577,12175],0); -ELEMENTS[41346] = Fluid3D([13176,13510,13220,12717],0); -ELEMENTS[41347] = Fluid3D([13220,13176,12717,13204],0); -ELEMENTS[41348] = Fluid3D([13510,13220,12717,12859],0); -ELEMENTS[41349] = Fluid3D([13220,12717,12859,12972],0); -ELEMENTS[41350] = Fluid3D([12859,13220,12972,13747],0); -ELEMENTS[41351] = Fluid3D([13220,12717,12972,13204],0); -ELEMENTS[41352] = Fluid3D([12972,13220,13204,13846],0); -ELEMENTS[41353] = Fluid3D([13176,12717,13204,12019],0); -ELEMENTS[41354] = Fluid3D([13220,12972,13747,13846],0); -ELEMENTS[41355] = Fluid3D([13176,13510,12717,12378],0); -ELEMENTS[41356] = Fluid3D([18220,18057,18295,18229],0); -ELEMENTS[41357] = Fluid3D([18295,18220,18229,18467],0); -ELEMENTS[41358] = Fluid3D([18057,18295,18229,18075],0); -ELEMENTS[41359] = Fluid3D([18229,18057,18075,18091],0); -ELEMENTS[41360] = Fluid3D([18075,18229,18091,18249],0); -ELEMENTS[41361] = Fluid3D([18229,18091,18249,18057],0); -ELEMENTS[41362] = Fluid3D([18057,18075,18091,17952],0); -ELEMENTS[41363] = Fluid3D([18075,18091,17952,18031],0); -ELEMENTS[41364] = Fluid3D([18091,17952,18031,18249],0); -ELEMENTS[41365] = Fluid3D([18091,17952,18249,18177],0); -ELEMENTS[41366] = Fluid3D([18031,18091,18249,18075],0); -ELEMENTS[41367] = Fluid3D([18249,18091,18177,18057],0); -ELEMENTS[41368] = Fluid3D([15225,14571,15132,15059],0); -ELEMENTS[41369] = Fluid3D([11857,11536,11347,12409],0); -ELEMENTS[41370] = Fluid3D([16225,16523,16558,15904],0); -ELEMENTS[41371] = Fluid3D([14193,13677,14070,14630],0); -ELEMENTS[41372] = Fluid3D([14900,14435,14606,15433],0); -ELEMENTS[41373] = Fluid3D([8170,7293,8469,7815],0); -ELEMENTS[41374] = Fluid3D([3568,3723,3274,3356],0); -ELEMENTS[41375] = Fluid3D([7839,7658,6951,7883],0); -ELEMENTS[41376] = Fluid3D([7839,7658,7883,8492],0); -ELEMENTS[41377] = Fluid3D([10747,10591,10061,9614],0); -ELEMENTS[41378] = Fluid3D([5741,5778,5206,5367],0); -ELEMENTS[41379] = Fluid3D([8364,7804,7978,7252],0); -ELEMENTS[41380] = Fluid3D([17884,17979,17787,17593],0); -ELEMENTS[41381] = Fluid3D([12622,12939,11982,12116],0); -ELEMENTS[41382] = Fluid3D([12939,11982,12116,12432],0); -ELEMENTS[41383] = Fluid3D([13180,13721,13863,12785],0); -ELEMENTS[41384] = Fluid3D([8743,8271,7749,9043],0); -ELEMENTS[41385] = Fluid3D([8441,8843,9000,9857],0); -ELEMENTS[41386] = Fluid3D([17782,18041,17743,17996],0); -ELEMENTS[41387] = Fluid3D([11691,11925,12321,12529],0); -ELEMENTS[41388] = Fluid3D([12321,11691,12529,12574],0); -ELEMENTS[41389] = Fluid3D([10330,9653,9230,9393],0); -ELEMENTS[41390] = Fluid3D([10636,10844,10594,9959],0); -ELEMENTS[41391] = Fluid3D([17259,17581,17321,17245],0); -ELEMENTS[41392] = Fluid3D([7234,6819,6467,7122],0); -ELEMENTS[41393] = Fluid3D([2800,2482,2602,2647],0); -ELEMENTS[41394] = Fluid3D([13066,13304,13265,12387],0); -ELEMENTS[41395] = Fluid3D([8166,8333,9009,8816],0); -ELEMENTS[41396] = Fluid3D([8166,8333,8816,8350],0); -ELEMENTS[41397] = Fluid3D([9009,8166,8816,9238],0); -ELEMENTS[41398] = Fluid3D([2291,2134,2092,2066],0); -ELEMENTS[41399] = Fluid3D([2793,3019,2935,3026],0); -ELEMENTS[41400] = Fluid3D([3019,2935,3026,3497],0); -ELEMENTS[41401] = Fluid3D([15203,15277,14918,15669],0); -ELEMENTS[41402] = Fluid3D([6177,5635,5611,6137],0); -ELEMENTS[41403] = Fluid3D([13810,14400,13811,14383],0); -ELEMENTS[41404] = Fluid3D([4331,4814,4798,4834],0); -ELEMENTS[41405] = Fluid3D([4798,4331,4834,4272],0); -ELEMENTS[41406] = Fluid3D([13830,13566,13177,14351],0); -ELEMENTS[41407] = Fluid3D([3947,3985,4088,3638],0); -ELEMENTS[41408] = Fluid3D([11473,10474,11164,10638],0); -ELEMENTS[41409] = Fluid3D([16786,16338,16918,16967],0); -ELEMENTS[41410] = Fluid3D([3939,3655,4048,3831],0); -ELEMENTS[41411] = Fluid3D([14489,14856,13957,14433],0); -ELEMENTS[41412] = Fluid3D([15212,14476,14716,14758],0); -ELEMENTS[41413] = Fluid3D([6926,6644,7214,6521],0); -ELEMENTS[41414] = Fluid3D([2735,2733,2426,2451],0); -ELEMENTS[41415] = Fluid3D([13111,13167,14039,13442],0); -ELEMENTS[41416] = Fluid3D([18067,17759,17974,17721],0); -ELEMENTS[41417] = Fluid3D([10169,10927,10132,9530],0); -ELEMENTS[41418] = Fluid3D([8252,9132,8270,7852],0); -ELEMENTS[41419] = Fluid3D([11945,11383,11171,11189],0); -ELEMENTS[41420] = Fluid3D([12565,13012,12911,13620],0); -ELEMENTS[41421] = Fluid3D([13012,12911,13620,13459],0); -ELEMENTS[41422] = Fluid3D([12911,13620,13459,13956],0); -ELEMENTS[41423] = Fluid3D([13620,13012,13459,13796],0); -ELEMENTS[41424] = Fluid3D([13620,13012,13796,13290],0); -ELEMENTS[41425] = Fluid3D([13012,13796,13290,13486],0); -ELEMENTS[41426] = Fluid3D([11064,11970,11981,12127],0); -ELEMENTS[41427] = Fluid3D([18234,18359,18145,18188],0); -ELEMENTS[41428] = Fluid3D([15830,16071,16189,16799],0); -ELEMENTS[41429] = Fluid3D([4519,4708,5124,4536],0); -ELEMENTS[41430] = Fluid3D([16975,17058,16699,16748],0); -ELEMENTS[41431] = Fluid3D([14826,14628,15271,14676],0); -ELEMENTS[41432] = Fluid3D([15984,16474,16410,16674],0); -ELEMENTS[41433] = Fluid3D([5346,4776,4872,4757],0); -ELEMENTS[41434] = Fluid3D([4776,4872,4757,4266],0); -ELEMENTS[41435] = Fluid3D([5346,4776,4757,4957],0); -ELEMENTS[41436] = Fluid3D([4776,4757,4957,4306],0); -ELEMENTS[41437] = Fluid3D([4757,4776,4266,4306],0); -ELEMENTS[41438] = Fluid3D([4776,4266,4306,3965],0); -ELEMENTS[41439] = Fluid3D([11023,11933,11201,11436],0); -ELEMENTS[41440] = Fluid3D([16266,16097,15611,15807],0); -ELEMENTS[41441] = Fluid3D([12554,12706,13215,12088],0); -ELEMENTS[41442] = Fluid3D([10452,10214,10754,10981],0); -ELEMENTS[41443] = Fluid3D([1846,1782,1814,1706],0); -ELEMENTS[41444] = Fluid3D([10093,10014,9095,9895],0); -ELEMENTS[41445] = Fluid3D([7678,6914,7127,7537],0); -ELEMENTS[41446] = Fluid3D([8062,9062,8469,7545],0); -ELEMENTS[41447] = Fluid3D([16949,16834,16977,16513],0); -ELEMENTS[41448] = Fluid3D([11305,10771,11084,10153],0); -ELEMENTS[41449] = Fluid3D([18464,18472,18434,18252],0); -ELEMENTS[41450] = Fluid3D([6719,6204,6556,5992],0); -ELEMENTS[41451] = Fluid3D([10993,11943,11710,11483],0); -ELEMENTS[41452] = Fluid3D([6463,5998,6220,6093],0); -ELEMENTS[41453] = Fluid3D([15085,15041,15488,15626],0); -ELEMENTS[41454] = Fluid3D([15488,15085,15626,16044],0); -ELEMENTS[41455] = Fluid3D([15626,15488,16044,16074],0); -ELEMENTS[41456] = Fluid3D([15488,16044,16074,16105],0); -ELEMENTS[41457] = Fluid3D([15488,16044,16105,15853],0); -ELEMENTS[41458] = Fluid3D([15488,16044,15853,15802],0); -ELEMENTS[41459] = Fluid3D([16044,16105,15853,16313],0); -ELEMENTS[41460] = Fluid3D([16044,15853,15802,16159],0); -ELEMENTS[41461] = Fluid3D([15853,15802,16159,15487],0); -ELEMENTS[41462] = Fluid3D([16105,15488,15853,15943],0); -ELEMENTS[41463] = Fluid3D([15853,16105,15943,16313],0); -ELEMENTS[41464] = Fluid3D([16105,15943,16313,16454],0); -ELEMENTS[41465] = Fluid3D([15943,15853,16313,15487],0); -ELEMENTS[41466] = Fluid3D([16105,15943,16454,15673],0); -ELEMENTS[41467] = Fluid3D([16105,15943,15673,15488],0); -ELEMENTS[41468] = Fluid3D([16044,16074,16105,16454],0); -ELEMENTS[41469] = Fluid3D([16074,16105,16454,15655],0); -ELEMENTS[41470] = Fluid3D([16159,15853,15487,16313],0); -ELEMENTS[41471] = Fluid3D([16159,15853,16313,16044],0); -ELEMENTS[41472] = Fluid3D([7805,7403,8182,7309],0); -ELEMENTS[41473] = Fluid3D([12421,12935,13291,13317],0); -ELEMENTS[41474] = Fluid3D([12935,13291,13317,13886],0); -ELEMENTS[41475] = Fluid3D([13317,12935,13886,13680],0); -ELEMENTS[41476] = Fluid3D([12421,12935,13317,12482],0); -ELEMENTS[41477] = Fluid3D([12935,13317,12482,12953],0); -ELEMENTS[41478] = Fluid3D([12935,13317,12953,13680],0); -ELEMENTS[41479] = Fluid3D([13317,12482,12953,13442],0); -ELEMENTS[41480] = Fluid3D([12953,13317,13442,13914],0); -ELEMENTS[41481] = Fluid3D([3113,2872,2762,2827],0); -ELEMENTS[41482] = Fluid3D([2872,2762,2827,2553],0); -ELEMENTS[41483] = Fluid3D([2762,2827,2553,2820],0); -ELEMENTS[41484] = Fluid3D([2553,2762,2820,2466],0); -ELEMENTS[41485] = Fluid3D([2553,2762,2466,2535],0); -ELEMENTS[41486] = Fluid3D([2466,2553,2535,2327],0); -ELEMENTS[41487] = Fluid3D([2466,2553,2327,2318],0); -ELEMENTS[41488] = Fluid3D([2466,2553,2318,2352],0); -ELEMENTS[41489] = Fluid3D([2466,2553,2352,2820],0); -ELEMENTS[41490] = Fluid3D([2553,2762,2535,2872],0); -ELEMENTS[41491] = Fluid3D([2553,2318,2352,2532],0); -ELEMENTS[41492] = Fluid3D([2535,2466,2327,2615],0); -ELEMENTS[41493] = Fluid3D([2327,2535,2615,2241],0); -ELEMENTS[41494] = Fluid3D([2327,2535,2241,2137],0); -ELEMENTS[41495] = Fluid3D([2762,2827,2820,3133],0); -ELEMENTS[41496] = Fluid3D([2352,2553,2532,2820],0); -ELEMENTS[41497] = Fluid3D([16459,16836,16898,16504],0); -ELEMENTS[41498] = Fluid3D([4544,5093,4672,4516],0); -ELEMENTS[41499] = Fluid3D([8070,8314,7466,8496],0); -ELEMENTS[41500] = Fluid3D([8070,8314,8496,9231],0); -ELEMENTS[41501] = Fluid3D([8675,7997,8614,7856],0); -ELEMENTS[41502] = Fluid3D([17131,17198,17084,17519],0); -ELEMENTS[41503] = Fluid3D([16184,16281,16403,15631],0); -ELEMENTS[41504] = Fluid3D([12718,13066,12405,13471],0); -ELEMENTS[41505] = Fluid3D([17288,17549,17363,17730],0); -ELEMENTS[41506] = Fluid3D([12555,12226,12468,13085],0); -ELEMENTS[41507] = Fluid3D([13874,14371,13660,14343],0); -ELEMENTS[41508] = Fluid3D([2703,2735,2426,2419],0); -ELEMENTS[41509] = Fluid3D([10037,10401,9839,9113],0); -ELEMENTS[41510] = Fluid3D([15221,14962,15308,15840],0); -ELEMENTS[41511] = Fluid3D([16229,16606,16626,16710],0); -ELEMENTS[41512] = Fluid3D([15725,15180,15467,15666],0); -ELEMENTS[41513] = Fluid3D([15467,15725,15666,16072],0); -ELEMENTS[41514] = Fluid3D([15467,15725,16072,16014],0); -ELEMENTS[41515] = Fluid3D([16072,15467,16014,15979],0); -ELEMENTS[41516] = Fluid3D([16072,15467,15979,15666],0); -ELEMENTS[41517] = Fluid3D([15979,16072,15666,16254],0); -ELEMENTS[41518] = Fluid3D([10005,9040,9424,9384],0); -ELEMENTS[41519] = Fluid3D([14934,14150,14531,14994],0); -ELEMENTS[41520] = Fluid3D([14934,14150,14994,14363],0); -ELEMENTS[41521] = Fluid3D([14531,14934,14994,15261],0); -ELEMENTS[41522] = Fluid3D([13872,14463,14706,13988],0); -ELEMENTS[41523] = Fluid3D([9839,9929,11019,10870],0); -ELEMENTS[41524] = Fluid3D([8499,8363,8031,8924],0); -ELEMENTS[41525] = Fluid3D([8499,8363,8924,9254],0); -ELEMENTS[41526] = Fluid3D([8031,8499,8924,8583],0); -ELEMENTS[41527] = Fluid3D([8924,8499,9254,9138],0); -ELEMENTS[41528] = Fluid3D([8924,8499,9138,8519],0); -ELEMENTS[41529] = Fluid3D([8499,9254,9138,8449],0); -ELEMENTS[41530] = Fluid3D([9254,9138,8449,9269],0); -ELEMENTS[41531] = Fluid3D([9254,9138,9269,9596],0); -ELEMENTS[41532] = Fluid3D([9138,9269,9596,8680],0); -ELEMENTS[41533] = Fluid3D([9269,9596,8680,9448],0); -ELEMENTS[41534] = Fluid3D([9269,9596,9448,9656],0); -ELEMENTS[41535] = Fluid3D([9254,8924,9138,9861],0); -ELEMENTS[41536] = Fluid3D([9138,9254,9861,10227],0); -ELEMENTS[41537] = Fluid3D([8680,9269,9448,9656],0); -ELEMENTS[41538] = Fluid3D([9138,8499,8449,8081],0); -ELEMENTS[41539] = Fluid3D([9138,8449,9269,8680],0); -ELEMENTS[41540] = Fluid3D([8449,9269,8680,8673],0); -ELEMENTS[41541] = Fluid3D([9269,9596,9656,9254],0); -ELEMENTS[41542] = Fluid3D([9656,9269,9254,8449],0); -ELEMENTS[41543] = Fluid3D([9269,8680,8673,9656],0); -ELEMENTS[41544] = Fluid3D([8673,9269,9656,8449],0); -ELEMENTS[41545] = Fluid3D([9254,9138,9596,10227],0); -ELEMENTS[41546] = Fluid3D([8499,8924,8583,8519],0); -ELEMENTS[41547] = Fluid3D([8924,9138,9861,9116],0); -ELEMENTS[41548] = Fluid3D([9138,9861,9116,9407],0); -ELEMENTS[41549] = Fluid3D([9116,9138,9407,8519],0); -ELEMENTS[41550] = Fluid3D([9407,9116,8519,9376],0); -ELEMENTS[41551] = Fluid3D([9116,8519,9376,9507],0); -ELEMENTS[41552] = Fluid3D([8924,9138,9116,8519],0); -ELEMENTS[41553] = Fluid3D([9407,9116,9376,10122],0); -ELEMENTS[41554] = Fluid3D([9116,8519,9507,8924],0); -ELEMENTS[41555] = Fluid3D([9507,9116,8924,9861],0); -ELEMENTS[41556] = Fluid3D([9507,9116,9861,10122],0); -ELEMENTS[41557] = Fluid3D([9138,8499,8081,8519],0); -ELEMENTS[41558] = Fluid3D([6110,6586,6599,5791],0); -ELEMENTS[41559] = Fluid3D([5589,5839,5413,5108],0); -ELEMENTS[41560] = Fluid3D([14452,14600,13959,13884],0); -ELEMENTS[41561] = Fluid3D([13775,13816,13545,12801],0); -ELEMENTS[41562] = Fluid3D([12099,12582,13145,12879],0); -ELEMENTS[41563] = Fluid3D([5911,5286,5946,5548],0); -ELEMENTS[41564] = Fluid3D([16513,16491,16227,16893],0); -ELEMENTS[41565] = Fluid3D([16513,16491,16893,16954],0); -ELEMENTS[41566] = Fluid3D([16441,15775,16372,15971],0); -ELEMENTS[41567] = Fluid3D([7119,7613,8065,6806],0); -ELEMENTS[41568] = Fluid3D([18522,18566,18426,18527],0); -ELEMENTS[41569] = Fluid3D([6446,6011,6370,5673],0); -ELEMENTS[41570] = Fluid3D([15474,15586,15197,14564],0); -ELEMENTS[41571] = Fluid3D([7244,7271,7786,6690],0); -ELEMENTS[41572] = Fluid3D([12515,12746,13137,13316],0); -ELEMENTS[41573] = Fluid3D([12515,12746,13316,12765],0); -ELEMENTS[41574] = Fluid3D([12746,13316,12765,12679],0); -ELEMENTS[41575] = Fluid3D([10261,9260,9973,9785],0); -ELEMENTS[41576] = Fluid3D([17750,17574,17452,17536],0); -ELEMENTS[41577] = Fluid3D([11956,11413,11552,12633],0); -ELEMENTS[41578] = Fluid3D([13954,14420,13753,14614],0); -ELEMENTS[41579] = Fluid3D([18391,18166,18248,18333],0); -ELEMENTS[41580] = Fluid3D([9845,10017,9755,8936],0); -ELEMENTS[41581] = Fluid3D([10621,10281,9618,10916],0); -ELEMENTS[41582] = Fluid3D([12185,11567,11429,11604],0); -ELEMENTS[41583] = Fluid3D([11320,11305,12112,11150],0); -ELEMENTS[41584] = Fluid3D([11320,11305,11150,10458],0); -ELEMENTS[41585] = Fluid3D([6052,5509,5576,6131],0); -ELEMENTS[41586] = Fluid3D([6076,5800,5468,5614],0); -ELEMENTS[41587] = Fluid3D([2914,3185,2844,3053],0); -ELEMENTS[41588] = Fluid3D([11639,10659,11382,11201],0); -ELEMENTS[41589] = Fluid3D([4914,4827,5223,5537],0); -ELEMENTS[41590] = Fluid3D([15535,15168,15022,14300],0); -ELEMENTS[41591] = Fluid3D([10391,10835,9855,11058],0); -ELEMENTS[41592] = Fluid3D([7962,7192,7608,7376],0); -ELEMENTS[41593] = Fluid3D([2240,2379,2114,2062],0); -ELEMENTS[41594] = Fluid3D([17003,16511,16691,16649],0); -ELEMENTS[41595] = Fluid3D([9615,9089,10120,9797],0); -ELEMENTS[41596] = Fluid3D([7053,7704,7023,6741],0); -ELEMENTS[41597] = Fluid3D([17529,17760,17916,17861],0); -ELEMENTS[41598] = Fluid3D([9907,9289,10410,10207],0); -ELEMENTS[41599] = Fluid3D([12572,13144,13451,13185],0); -ELEMENTS[41600] = Fluid3D([6722,6585,6614,7406],0); -ELEMENTS[41601] = Fluid3D([6722,6585,7406,6430],0); -ELEMENTS[41602] = Fluid3D([10815,10707,11663,11506],0); -ELEMENTS[41603] = Fluid3D([13007,13592,13428,14259],0); -ELEMENTS[41604] = Fluid3D([8028,8839,8913,8157],0); -ELEMENTS[41605] = Fluid3D([12232,11862,12912,13099],0); -ELEMENTS[41606] = Fluid3D([13453,14118,13829,14601],0); -ELEMENTS[41607] = Fluid3D([12179,12731,12518,11852],0); -ELEMENTS[41608] = Fluid3D([3106,2910,3087,2843],0); -ELEMENTS[41609] = Fluid3D([3087,3106,2843,3074],0); -ELEMENTS[41610] = Fluid3D([3106,2910,2843,2823],0); -ELEMENTS[41611] = Fluid3D([2843,3087,3074,2932],0); -ELEMENTS[41612] = Fluid3D([17027,17393,17378,16976],0); -ELEMENTS[41613] = Fluid3D([3111,2783,2885,2865],0); -ELEMENTS[41614] = Fluid3D([7238,7328,6656,7477],0); -ELEMENTS[41615] = Fluid3D([6656,7238,7477,6886],0); -ELEMENTS[41616] = Fluid3D([7328,6656,7477,7123],0); -ELEMENTS[41617] = Fluid3D([15559,15247,15813,16077],0); -ELEMENTS[41618] = Fluid3D([3480,3720,3671,3639],0); -ELEMENTS[41619] = Fluid3D([11835,11390,11365,10548],0); -ELEMENTS[41620] = Fluid3D([4854,5347,4830,4912],0); -ELEMENTS[41621] = Fluid3D([10084,9665,9944,9174],0); -ELEMENTS[41622] = Fluid3D([16846,17154,17035,16573],0); -ELEMENTS[41623] = Fluid3D([16787,16419,16415,16362],0); -ELEMENTS[41624] = Fluid3D([16718,16703,16358,17000],0); -ELEMENTS[41625] = Fluid3D([16718,16703,17000,17233],0); -ELEMENTS[41626] = Fluid3D([16703,16358,17000,16681],0); -ELEMENTS[41627] = Fluid3D([17000,16703,16681,16953],0); -ELEMENTS[41628] = Fluid3D([17000,16703,16953,17233],0); -ELEMENTS[41629] = Fluid3D([16703,16681,16953,16186],0); -ELEMENTS[41630] = Fluid3D([5004,5586,5589,5077],0); -ELEMENTS[41631] = Fluid3D([9510,10142,10630,10928],0); -ELEMENTS[41632] = Fluid3D([14327,13619,14286,14319],0); -ELEMENTS[41633] = Fluid3D([5512,4883,5472,5058],0); -ELEMENTS[41634] = Fluid3D([7970,8115,7626,7311],0); -ELEMENTS[41635] = Fluid3D([7626,7970,7311,7520],0); -ELEMENTS[41636] = Fluid3D([8115,7626,7311,7078],0); -ELEMENTS[41637] = Fluid3D([7970,8115,7311,7714],0); -ELEMENTS[41638] = Fluid3D([7311,7970,7714,7096],0); -ELEMENTS[41639] = Fluid3D([8115,7311,7714,7190],0); -ELEMENTS[41640] = Fluid3D([7970,8115,7714,8311],0); -ELEMENTS[41641] = Fluid3D([8115,7714,8311,7190],0); -ELEMENTS[41642] = Fluid3D([7714,7970,8311,8348],0); -ELEMENTS[41643] = Fluid3D([8311,7714,8348,7510],0); -ELEMENTS[41644] = Fluid3D([7714,8348,7510,7970],0); -ELEMENTS[41645] = Fluid3D([8311,7714,7510,7190],0); -ELEMENTS[41646] = Fluid3D([13183,13150,12433,13018],0); -ELEMENTS[41647] = Fluid3D([13183,13150,13018,13899],0); -ELEMENTS[41648] = Fluid3D([13150,13018,13899,13420],0); -ELEMENTS[41649] = Fluid3D([13150,13018,13420,12498],0); -ELEMENTS[41650] = Fluid3D([13899,13150,13420,14282],0); -ELEMENTS[41651] = Fluid3D([3138,3069,2760,3155],0); -ELEMENTS[41652] = Fluid3D([14491,14832,14615,15020],0); -ELEMENTS[41653] = Fluid3D([16831,16836,16567,16423],0); -ELEMENTS[41654] = Fluid3D([5033,4695,4884,4365],0); -ELEMENTS[41655] = Fluid3D([9217,8299,9035,8895],0); -ELEMENTS[41656] = Fluid3D([7494,6887,7454,7093],0); -ELEMENTS[41657] = Fluid3D([7454,7494,7093,7778],0); -ELEMENTS[41658] = Fluid3D([7093,7454,7778,7662],0); -ELEMENTS[41659] = Fluid3D([7494,7093,7778,6916],0); -ELEMENTS[41660] = Fluid3D([7093,7778,6916,7107],0); -ELEMENTS[41661] = Fluid3D([6488,5996,5915,5857],0); -ELEMENTS[41662] = Fluid3D([11807,11399,12350,11441],0); -ELEMENTS[41663] = Fluid3D([5311,4850,4752,5031],0); -ELEMENTS[41664] = Fluid3D([4752,5311,5031,4870],0); -ELEMENTS[41665] = Fluid3D([5031,4752,4870,4650],0); -ELEMENTS[41666] = Fluid3D([5311,4850,5031,5530],0); -ELEMENTS[41667] = Fluid3D([4870,5031,4650,5524],0); -ELEMENTS[41668] = Fluid3D([10425,10540,11399,11366],0); -ELEMENTS[41669] = Fluid3D([2708,2464,2637,2394],0); -ELEMENTS[41670] = Fluid3D([15866,16232,15709,16079],0); -ELEMENTS[41671] = Fluid3D([15709,15866,16079,15314],0); -ELEMENTS[41672] = Fluid3D([15866,16232,16079,16472],0); -ELEMENTS[41673] = Fluid3D([8054,8599,8568,7402],0); -ELEMENTS[41674] = Fluid3D([16914,16385,16830,16727],0); -ELEMENTS[41675] = Fluid3D([8534,8785,9495,8790],0); -ELEMENTS[41676] = Fluid3D([11653,10613,11310,11492],0); -ELEMENTS[41677] = Fluid3D([14293,13557,13382,13928],0); -ELEMENTS[41678] = Fluid3D([14320,14008,14785,14249],0); -ELEMENTS[41679] = Fluid3D([14785,14320,14249,14784],0); -ELEMENTS[41680] = Fluid3D([14320,14249,14784,13914],0); -ELEMENTS[41681] = Fluid3D([14249,14785,14784,14946],0); -ELEMENTS[41682] = Fluid3D([14320,14008,14249,13442],0); -ELEMENTS[41683] = Fluid3D([14008,14785,14249,14395],0); -ELEMENTS[41684] = Fluid3D([14785,14249,14395,14946],0); -ELEMENTS[41685] = Fluid3D([8359,8302,7581,8771],0); -ELEMENTS[41686] = Fluid3D([10173,9571,10392,10674],0); -ELEMENTS[41687] = Fluid3D([5875,5243,5347,5753],0); -ELEMENTS[41688] = Fluid3D([13814,13282,13300,13731],0); -ELEMENTS[41689] = Fluid3D([4280,4429,4422,4769],0); -ELEMENTS[41690] = Fluid3D([4429,4422,4769,5035],0); -ELEMENTS[41691] = Fluid3D([3419,3179,3333,3794],0); -ELEMENTS[41692] = Fluid3D([16485,16573,16542,17035],0); -ELEMENTS[41693] = Fluid3D([18413,18310,18268,18421],0); -ELEMENTS[41694] = Fluid3D([6416,6630,6490,7223],0); -ELEMENTS[41695] = Fluid3D([9595,9502,10027,10397],0); -ELEMENTS[41696] = Fluid3D([8774,7871,8808,8863],0); -ELEMENTS[41697] = Fluid3D([14859,14847,14712,15428],0); -ELEMENTS[41698] = Fluid3D([4045,4134,3755,3632],0); -ELEMENTS[41699] = Fluid3D([4045,4134,3632,3930],0); -ELEMENTS[41700] = Fluid3D([13301,14503,14483,14173],0); -ELEMENTS[41701] = Fluid3D([14503,14483,14173,14619],0); -ELEMENTS[41702] = Fluid3D([13301,14503,14173,13984],0); -ELEMENTS[41703] = Fluid3D([8970,9046,8304,9131],0); -ELEMENTS[41704] = Fluid3D([4000,4301,4482,4471],0); -ELEMENTS[41705] = Fluid3D([5809,6067,6590,5970],0); -ELEMENTS[41706] = Fluid3D([17596,17293,17331,17705],0); -ELEMENTS[41707] = Fluid3D([17369,17644,17551,17822],0); -ELEMENTS[41708] = Fluid3D([2390,2146,2197,2250],0); -ELEMENTS[41709] = Fluid3D([7053,6741,7487,7704],0); -ELEMENTS[41710] = Fluid3D([2422,2214,2367,2200],0); -ELEMENTS[41711] = Fluid3D([2367,2422,2200,2326],0); -ELEMENTS[41712] = Fluid3D([2422,2200,2326,2222],0); -ELEMENTS[41713] = Fluid3D([2200,2367,2326,2210],0); -ELEMENTS[41714] = Fluid3D([2214,2367,2200,2210],0); -ELEMENTS[41715] = Fluid3D([2422,2214,2200,2222],0); -ELEMENTS[41716] = Fluid3D([16919,17067,16852,17297],0); -ELEMENTS[41717] = Fluid3D([17138,17463,17573,17478],0); -ELEMENTS[41718] = Fluid3D([18653,18681,18689,18678],0); -ELEMENTS[41719] = Fluid3D([18653,18681,18678,18650],0); -ELEMENTS[41720] = Fluid3D([10266,10918,10873,10065],0); -ELEMENTS[41721] = Fluid3D([10266,10918,10065,10003],0); -ELEMENTS[41722] = Fluid3D([10873,10266,10065,9622],0); -ELEMENTS[41723] = Fluid3D([10266,10065,9622,10003],0); -ELEMENTS[41724] = Fluid3D([6909,7317,7841,7035],0); -ELEMENTS[41725] = Fluid3D([9096,9311,9587,8322],0); -ELEMENTS[41726] = Fluid3D([12878,13080,12152,12580],0); -ELEMENTS[41727] = Fluid3D([13080,12152,12580,12514],0); -ELEMENTS[41728] = Fluid3D([12580,13080,12514,13353],0); -ELEMENTS[41729] = Fluid3D([12514,12580,13353,12705],0); -ELEMENTS[41730] = Fluid3D([12514,12580,12705,11855],0); -ELEMENTS[41731] = Fluid3D([12514,12580,11855,12152],0); -ELEMENTS[41732] = Fluid3D([12580,12705,11855,13125],0); -ELEMENTS[41733] = Fluid3D([12580,13353,12705,13125],0); -ELEMENTS[41734] = Fluid3D([12705,12514,11855,12101],0); -ELEMENTS[41735] = Fluid3D([11855,12705,12101,12492],0); -ELEMENTS[41736] = Fluid3D([12705,12514,12101,13089],0); -ELEMENTS[41737] = Fluid3D([13353,12514,12705,13089],0); -ELEMENTS[41738] = Fluid3D([12580,13080,13353,12878],0); -ELEMENTS[41739] = Fluid3D([12514,11855,12101,11698],0); -ELEMENTS[41740] = Fluid3D([14478,14956,15083,15081],0); -ELEMENTS[41741] = Fluid3D([3087,3318,3133,2910],0); -ELEMENTS[41742] = Fluid3D([18034,17804,17933,17912],0); -ELEMENTS[41743] = Fluid3D([17804,17933,17912,17592],0); -ELEMENTS[41744] = Fluid3D([3482,3231,3528,3050],0); -ELEMENTS[41745] = Fluid3D([5158,5164,5610,5941],0); -ELEMENTS[41746] = Fluid3D([18053,17983,18242,18120],0); -ELEMENTS[41747] = Fluid3D([17223,16885,17308,17390],0); -ELEMENTS[41748] = Fluid3D([5095,5399,4767,5052],0); -ELEMENTS[41749] = Fluid3D([14631,13749,13978,13952],0); -ELEMENTS[41750] = Fluid3D([6160,6353,5744,6912],0); -ELEMENTS[41751] = Fluid3D([5514,5395,5951,5515],0); -ELEMENTS[41752] = Fluid3D([16157,15974,16557,16348],0); -ELEMENTS[41753] = Fluid3D([12455,12054,12831,12884],0); -ELEMENTS[41754] = Fluid3D([15949,15670,15354,15056],0); -ELEMENTS[41755] = Fluid3D([17720,17379,17722,17533],0); -ELEMENTS[41756] = Fluid3D([14115,14661,14296,14793],0); -ELEMENTS[41757] = Fluid3D([2338,2287,2440,2588],0); -ELEMENTS[41758] = Fluid3D([18243,18345,18347,18442],0); -ELEMENTS[41759] = Fluid3D([11328,10281,10621,10916],0); -ELEMENTS[41760] = Fluid3D([3065,2869,2676,2955],0); -ELEMENTS[41761] = Fluid3D([2869,2676,2955,2699],0); -ELEMENTS[41762] = Fluid3D([2869,2676,2699,2454],0); -ELEMENTS[41763] = Fluid3D([2955,2869,2699,3140],0); -ELEMENTS[41764] = Fluid3D([3190,3007,3060,2864],0); -ELEMENTS[41765] = Fluid3D([3190,3007,2864,2956],0); -ELEMENTS[41766] = Fluid3D([3007,3060,2864,2799],0); -ELEMENTS[41767] = Fluid3D([3060,3190,2864,2956],0); -ELEMENTS[41768] = Fluid3D([2864,3007,2799,2686],0); -ELEMENTS[41769] = Fluid3D([2864,3007,2686,2675],0); -ELEMENTS[41770] = Fluid3D([3060,2864,2799,2778],0); -ELEMENTS[41771] = Fluid3D([2686,2864,2675,2539],0); -ELEMENTS[41772] = Fluid3D([2675,2686,2539,2314],0); -ELEMENTS[41773] = Fluid3D([2799,2864,2686,2539],0); -ELEMENTS[41774] = Fluid3D([2799,3060,2778,3138],0); -ELEMENTS[41775] = Fluid3D([3060,2864,2778,2741],0); -ELEMENTS[41776] = Fluid3D([2799,2864,2539,2778],0); -ELEMENTS[41777] = Fluid3D([2686,2799,2539,2431],0); -ELEMENTS[41778] = Fluid3D([3007,2799,2686,2852],0); -ELEMENTS[41779] = Fluid3D([2686,3007,2852,2855],0); -ELEMENTS[41780] = Fluid3D([2864,2675,2539,2460],0); -ELEMENTS[41781] = Fluid3D([2675,2539,2460,2314],0); -ELEMENTS[41782] = Fluid3D([2539,2460,2314,2503],0); -ELEMENTS[41783] = Fluid3D([2539,2460,2503,2778],0); -ELEMENTS[41784] = Fluid3D([2539,2864,2460,2778],0); -ELEMENTS[41785] = Fluid3D([3007,2864,2956,2944],0); -ELEMENTS[41786] = Fluid3D([3007,2799,2852,3096],0); -ELEMENTS[41787] = Fluid3D([3007,2799,3096,3060],0); -ELEMENTS[41788] = Fluid3D([2799,3096,3060,3138],0); -ELEMENTS[41789] = Fluid3D([2799,2686,2852,2431],0); -ELEMENTS[41790] = Fluid3D([3007,2864,2944,2675],0); -ELEMENTS[41791] = Fluid3D([3190,3007,2956,2944],0); -ELEMENTS[41792] = Fluid3D([2956,3190,2944,3273],0); -ELEMENTS[41793] = Fluid3D([2799,2852,3096,3138],0); -ELEMENTS[41794] = Fluid3D([9940,9150,8814,9472],0); -ELEMENTS[41795] = Fluid3D([8814,9940,9472,9954],0); -ELEMENTS[41796] = Fluid3D([8639,8217,7992,7618],0); -ELEMENTS[41797] = Fluid3D([13988,14648,14463,14706],0); -ELEMENTS[41798] = Fluid3D([12890,12965,12463,11773],0); -ELEMENTS[41799] = Fluid3D([12463,12890,11773,12126],0); -ELEMENTS[41800] = Fluid3D([12890,11773,12126,12180],0); -ELEMENTS[41801] = Fluid3D([11773,12463,12126,11886],0); -ELEMENTS[41802] = Fluid3D([12126,11773,11886,11185],0); -ELEMENTS[41803] = Fluid3D([11773,12463,11886,11396],0); -ELEMENTS[41804] = Fluid3D([11886,11773,11396,10853],0); -ELEMENTS[41805] = Fluid3D([11773,12463,11396,11485],0); -ELEMENTS[41806] = Fluid3D([11773,11396,10853,11485],0); -ELEMENTS[41807] = Fluid3D([11396,10853,11485,11369],0); -ELEMENTS[41808] = Fluid3D([11485,11396,11369,12463],0); -ELEMENTS[41809] = Fluid3D([11396,10853,11369,11072],0); -ELEMENTS[41810] = Fluid3D([11369,11396,11072,11886],0); -ELEMENTS[41811] = Fluid3D([11396,10853,11072,11886],0); -ELEMENTS[41812] = Fluid3D([12463,11886,11396,11369],0); -ELEMENTS[41813] = Fluid3D([12126,11773,11185,12180],0); -ELEMENTS[41814] = Fluid3D([11072,11369,11886,12401],0); -ELEMENTS[41815] = Fluid3D([10131,9286,10207,9294],0); -ELEMENTS[41816] = Fluid3D([12649,12231,11857,12131],0); -ELEMENTS[41817] = Fluid3D([2079,2219,2187,2043],0); -ELEMENTS[41818] = Fluid3D([2187,2079,2043,1973],0); -ELEMENTS[41819] = Fluid3D([4326,4540,4844,4206],0); -ELEMENTS[41820] = Fluid3D([15259,15047,14678,15304],0); -ELEMENTS[41821] = Fluid3D([13085,12689,12538,12226],0); -ELEMENTS[41822] = Fluid3D([12582,13090,13467,13055],0); -ELEMENTS[41823] = Fluid3D([3881,4176,4393,4067],0); -ELEMENTS[41824] = Fluid3D([11545,12011,11628,12043],0); -ELEMENTS[41825] = Fluid3D([11628,11545,12043,10652],0); -ELEMENTS[41826] = Fluid3D([15822,16135,15571,15281],0); -ELEMENTS[41827] = Fluid3D([12380,13280,12969,13023],0); -ELEMENTS[41828] = Fluid3D([13225,13788,12927,12884],0); -ELEMENTS[41829] = Fluid3D([10256,10393,10629,9456],0); -ELEMENTS[41830] = Fluid3D([18426,18375,18522,18527],0); -ELEMENTS[41831] = Fluid3D([1880,1759,1791,1915],0); -ELEMENTS[41832] = Fluid3D([15638,16112,16025,16377],0); -ELEMENTS[41833] = Fluid3D([15638,16112,16377,15914],0); -ELEMENTS[41834] = Fluid3D([11149,11721,11963,12348],0); -ELEMENTS[41835] = Fluid3D([14583,14941,14098,13809],0); -ELEMENTS[41836] = Fluid3D([9408,10142,9704,10612],0); -ELEMENTS[41837] = Fluid3D([6608,6463,6802,6093],0); -ELEMENTS[41838] = Fluid3D([18617,18551,18644,18591],0); -ELEMENTS[41839] = Fluid3D([7122,6562,6348,6715],0); -ELEMENTS[41840] = Fluid3D([12675,13464,13489,12881],0); -ELEMENTS[41841] = Fluid3D([7391,7639,6766,7092],0); -ELEMENTS[41842] = Fluid3D([6766,7391,7092,6742],0); -ELEMENTS[41843] = Fluid3D([7391,7639,7092,8218],0); -ELEMENTS[41844] = Fluid3D([6742,6052,6643,6766],0); -ELEMENTS[41845] = Fluid3D([17850,18131,18016,18191],0); -ELEMENTS[41846] = Fluid3D([3670,3319,3612,3330],0); -ELEMENTS[41847] = Fluid3D([14400,13583,13811,13806],0); -ELEMENTS[41848] = Fluid3D([6711,6082,6918,6368],0); -ELEMENTS[41849] = Fluid3D([15631,15548,15640,16184],0); -ELEMENTS[41850] = Fluid3D([6197,7024,6438,6388],0); -ELEMENTS[41851] = Fluid3D([9611,9004,8778,9814],0); -ELEMENTS[41852] = Fluid3D([13518,12828,13123,12330],0); -ELEMENTS[41853] = Fluid3D([16713,16504,16125,16667],0); -ELEMENTS[41854] = Fluid3D([10959,11900,11364,11820],0); -ELEMENTS[41855] = Fluid3D([6298,5842,5555,5704],0); -ELEMENTS[41856] = Fluid3D([11511,11442,12435,11813],0); -ELEMENTS[41857] = Fluid3D([12435,11511,11813,11482],0); -ELEMENTS[41858] = Fluid3D([11511,11813,11482,11133],0); -ELEMENTS[41859] = Fluid3D([12435,11511,11482,12456],0); -ELEMENTS[41860] = Fluid3D([11511,11482,12456,11845],0); -ELEMENTS[41861] = Fluid3D([11813,11482,11133,12117],0); -ELEMENTS[41862] = Fluid3D([11813,11482,12117,12435],0); -ELEMENTS[41863] = Fluid3D([11511,11442,11813,11133],0); -ELEMENTS[41864] = Fluid3D([17935,18058,18135,18265],0); -ELEMENTS[41865] = Fluid3D([11906,12657,12193,11533],0); -ELEMENTS[41866] = Fluid3D([16934,17408,17335,16991],0); -ELEMENTS[41867] = Fluid3D([8366,8798,8866,9658],0); -ELEMENTS[41868] = Fluid3D([10082,9776,10470,9208],0); -ELEMENTS[41869] = Fluid3D([8051,7524,8090,7517],0); -ELEMENTS[41870] = Fluid3D([7821,8122,8389,8885],0); -ELEMENTS[41871] = Fluid3D([14421,14432,13674,13784],0); -ELEMENTS[41872] = Fluid3D([9451,9391,8489,8742],0); -ELEMENTS[41873] = Fluid3D([6464,6460,6934,6235],0); -ELEMENTS[41874] = Fluid3D([4603,4548,4084,4592],0); -ELEMENTS[41875] = Fluid3D([16316,16605,16507,16021],0); -ELEMENTS[41876] = Fluid3D([15385,15484,15735,15232],0); -ELEMENTS[41877] = Fluid3D([14513,14460,14277,13754],0); -ELEMENTS[41878] = Fluid3D([5733,5138,5409,5853],0); -ELEMENTS[41879] = Fluid3D([3478,3447,3880,3641],0); -ELEMENTS[41880] = Fluid3D([10678,11452,10659,10051],0); -ELEMENTS[41881] = Fluid3D([9372,9104,8404,9072],0); -ELEMENTS[41882] = Fluid3D([8404,9372,9072,8689],0); -ELEMENTS[41883] = Fluid3D([9372,9072,8689,9753],0); -ELEMENTS[41884] = Fluid3D([9072,8404,8689,8330],0); -ELEMENTS[41885] = Fluid3D([8689,9072,8330,9753],0); -ELEMENTS[41886] = Fluid3D([18213,18207,17996,18062],0); -ELEMENTS[41887] = Fluid3D([9214,8935,9958,9923],0); -ELEMENTS[41888] = Fluid3D([7664,8462,8196,7542],0); -ELEMENTS[41889] = Fluid3D([2890,2665,3050,2649],0); -ELEMENTS[41890] = Fluid3D([17555,17670,17839,17515],0); -ELEMENTS[41891] = Fluid3D([12089,11081,11757,11591],0); -ELEMENTS[41892] = Fluid3D([10904,10182,9734,9932],0); -ELEMENTS[41893] = Fluid3D([13753,13967,13080,13250],0); -ELEMENTS[41894] = Fluid3D([10636,10456,10844,9959],0); -ELEMENTS[41895] = Fluid3D([10115,10128,9348,9442],0); -ELEMENTS[41896] = Fluid3D([14843,15122,14674,15659],0); -ELEMENTS[41897] = Fluid3D([5813,6402,6459,6217],0); -ELEMENTS[41898] = Fluid3D([5419,5595,5225,5969],0); -ELEMENTS[41899] = Fluid3D([8810,9306,8006,8412],0); -ELEMENTS[41900] = Fluid3D([8810,9306,8412,9544],0); -ELEMENTS[41901] = Fluid3D([8810,9306,9544,9785],0); -ELEMENTS[41902] = Fluid3D([5689,6306,5887,6031],0); -ELEMENTS[41903] = Fluid3D([14138,14383,14904,13810],0); -ELEMENTS[41904] = Fluid3D([3989,3907,4116,3586],0); -ELEMENTS[41905] = Fluid3D([3820,4004,3671,3893],0); -ELEMENTS[41906] = Fluid3D([7319,7667,6751,7972],0); -ELEMENTS[41907] = Fluid3D([11148,12046,11988,10806],0); -ELEMENTS[41908] = Fluid3D([6565,5919,6282,5676],0); -ELEMENTS[41909] = Fluid3D([16786,16425,16338,16967],0); -ELEMENTS[41910] = Fluid3D([2898,3107,3035,2798],0); -ELEMENTS[41911] = Fluid3D([15212,14716,15405,14758],0); -ELEMENTS[41912] = Fluid3D([6911,6588,7253,6180],0); -ELEMENTS[41913] = Fluid3D([11797,11459,10716,11394],0); -ELEMENTS[41914] = Fluid3D([11797,11459,11394,11812],0); -ELEMENTS[41915] = Fluid3D([10716,11797,11394,10954],0); -ELEMENTS[41916] = Fluid3D([11797,11394,10954,11907],0); -ELEMENTS[41917] = Fluid3D([11797,11394,11907,12299],0); -ELEMENTS[41918] = Fluid3D([11394,10954,11907,11267],0); -ELEMENTS[41919] = Fluid3D([11394,10716,10954,10390],0); -ELEMENTS[41920] = Fluid3D([10954,11394,10390,11267],0); -ELEMENTS[41921] = Fluid3D([10954,11907,11267,11981],0); -ELEMENTS[41922] = Fluid3D([11907,11267,11981,12124],0); -ELEMENTS[41923] = Fluid3D([11907,11267,12124,11394],0); -ELEMENTS[41924] = Fluid3D([12124,11907,11394,12299],0); -ELEMENTS[41925] = Fluid3D([12124,11907,12299,12887],0); -ELEMENTS[41926] = Fluid3D([11981,11907,12124,12887],0); -ELEMENTS[41927] = Fluid3D([11797,11394,12299,11812],0); -ELEMENTS[41928] = Fluid3D([11907,11797,12299,12887],0); -ELEMENTS[41929] = Fluid3D([11459,11394,11812,10477],0); -ELEMENTS[41930] = Fluid3D([11812,11459,10477,10943],0); -ELEMENTS[41931] = Fluid3D([10954,11907,11981,11797],0); -ELEMENTS[41932] = Fluid3D([5944,6179,6062,6501],0); -ELEMENTS[41933] = Fluid3D([11373,11316,11325,10813],0); -ELEMENTS[41934] = Fluid3D([11373,11316,10813,11197],0); -ELEMENTS[41935] = Fluid3D([11316,10813,11197,10363],0); -ELEMENTS[41936] = Fluid3D([10813,11197,10363,10464],0); -ELEMENTS[41937] = Fluid3D([10813,11197,10464,11241],0); -ELEMENTS[41938] = Fluid3D([10813,11197,11241,11373],0); -ELEMENTS[41939] = Fluid3D([10464,10813,11241,11317],0); -ELEMENTS[41940] = Fluid3D([11197,10464,11241,10524],0); -ELEMENTS[41941] = Fluid3D([10464,11241,10524,11134],0); -ELEMENTS[41942] = Fluid3D([12092,11562,11821,11228],0); -ELEMENTS[41943] = Fluid3D([12573,12352,12814,13100],0); -ELEMENTS[41944] = Fluid3D([14493,14216,14796,15160],0); -ELEMENTS[41945] = Fluid3D([11783,12524,12180,11326],0); -ELEMENTS[41946] = Fluid3D([10121,9336,10313,10561],0); -ELEMENTS[41947] = Fluid3D([4708,4369,4643,5076],0); -ELEMENTS[41948] = Fluid3D([4643,4708,5076,5323],0); -ELEMENTS[41949] = Fluid3D([4708,5076,5323,5124],0); -ELEMENTS[41950] = Fluid3D([14181,14168,13604,13553],0); -ELEMENTS[41951] = Fluid3D([14181,14168,13553,14436],0); -ELEMENTS[41952] = Fluid3D([7629,6788,7180,7266],0); -ELEMENTS[41953] = Fluid3D([7648,7288,7780,8607],0); -ELEMENTS[41954] = Fluid3D([7288,7780,8607,7882],0); -ELEMENTS[41955] = Fluid3D([7288,7780,7882,8112],0); -ELEMENTS[41956] = Fluid3D([7288,7780,8112,7234],0); -ELEMENTS[41957] = Fluid3D([8607,7288,7882,7648],0); -ELEMENTS[41958] = Fluid3D([7882,7288,8112,7234],0); -ELEMENTS[41959] = Fluid3D([11529,11201,11382,10475],0); -ELEMENTS[41960] = Fluid3D([7497,7979,7794,8877],0); -ELEMENTS[41961] = Fluid3D([14801,14753,15445,15574],0); -ELEMENTS[41962] = Fluid3D([5110,4689,5299,5364],0); -ELEMENTS[41963] = Fluid3D([5299,5110,5364,5863],0); -ELEMENTS[41964] = Fluid3D([16147,16349,15780,15566],0); -ELEMENTS[41965] = Fluid3D([8089,8374,7652,8951],0); -ELEMENTS[41966] = Fluid3D([9885,10233,9231,10096],0); -ELEMENTS[41967] = Fluid3D([7537,6780,6914,6680],0); -ELEMENTS[41968] = Fluid3D([4087,3906,3897,3458],0); -ELEMENTS[41969] = Fluid3D([9619,8875,8865,9824],0); -ELEMENTS[41970] = Fluid3D([13188,12553,13499,13158],0); -ELEMENTS[41971] = Fluid3D([17341,17558,17258,17419],0); -ELEMENTS[41972] = Fluid3D([6055,6498,5998,5926],0); -ELEMENTS[41973] = Fluid3D([18615,18643,18584,18520],0); -ELEMENTS[41974] = Fluid3D([11518,10851,11932,11096],0); -ELEMENTS[41975] = Fluid3D([11518,10851,11096,10825],0); -ELEMENTS[41976] = Fluid3D([17678,17691,17444,17173],0); -ELEMENTS[41977] = Fluid3D([14269,14788,14188,14892],0); -ELEMENTS[41978] = Fluid3D([8276,8182,9054,7811],0); -ELEMENTS[41979] = Fluid3D([6214,5665,5711,5927],0); -ELEMENTS[41980] = Fluid3D([6214,5665,5927,6084],0); -ELEMENTS[41981] = Fluid3D([5927,6214,6084,6531],0); -ELEMENTS[41982] = Fluid3D([5711,6214,5927,6515],0); -ELEMENTS[41983] = Fluid3D([6214,5927,6515,6531],0); -ELEMENTS[41984] = Fluid3D([16857,16432,16337,16654],0); -ELEMENTS[41985] = Fluid3D([16337,16857,16654,16717],0); -ELEMENTS[41986] = Fluid3D([16654,16337,16717,16613],0); -ELEMENTS[41987] = Fluid3D([16654,16337,16613,16140],0); -ELEMENTS[41988] = Fluid3D([5047,4867,5017,5479],0); -ELEMENTS[41989] = Fluid3D([8488,7662,8439,7614],0); -ELEMENTS[41990] = Fluid3D([16518,16122,16175,16445],0); -ELEMENTS[41991] = Fluid3D([7674,8548,8144,8285],0); -ELEMENTS[41992] = Fluid3D([11666,12640,12772,12419],0); -ELEMENTS[41993] = Fluid3D([5530,5278,5305,4850],0); -ELEMENTS[41994] = Fluid3D([3077,3019,3388,2997],0); -ELEMENTS[41995] = Fluid3D([17054,16583,16761,16921],0); -ELEMENTS[41996] = Fluid3D([6809,7655,7297,7820],0); -ELEMENTS[41997] = Fluid3D([11653,12103,11136,11205],0); -ELEMENTS[41998] = Fluid3D([12103,11136,11205,11833],0); -ELEMENTS[41999] = Fluid3D([17944,17963,17569,17802],0); -ELEMENTS[42000] = Fluid3D([17697,17889,18015,17856],0); -ELEMENTS[42001] = Fluid3D([9212,10051,9744,8925],0); -ELEMENTS[42002] = Fluid3D([9744,9212,8925,8375],0); -ELEMENTS[42003] = Fluid3D([8250,8051,7836,7329],0); -ELEMENTS[42004] = Fluid3D([7357,7887,8361,8017],0); -ELEMENTS[42005] = Fluid3D([13361,12890,12463,12830],0); -ELEMENTS[42006] = Fluid3D([16013,15878,16315,16704],0); -ELEMENTS[42007] = Fluid3D([15850,15946,16364,15892],0); -ELEMENTS[42008] = Fluid3D([6174,5690,6030,5398],0); -ELEMENTS[42009] = Fluid3D([16225,16021,16523,15904],0); -ELEMENTS[42010] = Fluid3D([12302,12409,11645,12367],0); -ELEMENTS[42011] = Fluid3D([15629,15855,15783,16303],0); -ELEMENTS[42012] = Fluid3D([16890,17139,17334,16913],0); -ELEMENTS[42013] = Fluid3D([8776,9372,8404,8492],0); -ELEMENTS[42014] = Fluid3D([12319,13067,12857,12748],0); -ELEMENTS[42015] = Fluid3D([3274,3635,3259,3235],0); -ELEMENTS[42016] = Fluid3D([8322,8000,7484,7566],0); -ELEMENTS[42017] = Fluid3D([8543,8425,7869,8847],0); -ELEMENTS[42018] = Fluid3D([2188,2233,2380,2401],0); -ELEMENTS[42019] = Fluid3D([15023,14868,15638,14997],0); -ELEMENTS[42020] = Fluid3D([6906,7749,7241,7253],0); -ELEMENTS[42021] = Fluid3D([17334,17529,17463,17742],0); -ELEMENTS[42022] = Fluid3D([9837,10249,10940,10668],0); -ELEMENTS[42023] = Fluid3D([9262,8470,9414,8962],0); -ELEMENTS[42024] = Fluid3D([9262,8470,8962,7895],0); -ELEMENTS[42025] = Fluid3D([8962,9262,7895,9080],0); -ELEMENTS[42026] = Fluid3D([8962,9262,9080,9884],0); -ELEMENTS[42027] = Fluid3D([10922,10480,9692,10036],0); -ELEMENTS[42028] = Fluid3D([13066,13265,12390,12387],0); -ELEMENTS[42029] = Fluid3D([10743,9817,10640,10012],0); -ELEMENTS[42030] = Fluid3D([14018,14375,13778,13575],0); -ELEMENTS[42031] = Fluid3D([14375,13778,13575,13872],0); -ELEMENTS[42032] = Fluid3D([14018,14375,13575,14393],0); -ELEMENTS[42033] = Fluid3D([10837,10333,9638,10145],0); -ELEMENTS[42034] = Fluid3D([2269,2372,2337,2135],0); -ELEMENTS[42035] = Fluid3D([14422,13769,14639,13578],0); -ELEMENTS[42036] = Fluid3D([15446,15384,15888,15826],0); -ELEMENTS[42037] = Fluid3D([15378,15854,16035,15617],0); -ELEMENTS[42038] = Fluid3D([9512,9111,8444,9373],0); -ELEMENTS[42039] = Fluid3D([14931,15200,15417,15920],0); -ELEMENTS[42040] = Fluid3D([5089,5700,5399,5770],0); -ELEMENTS[42041] = Fluid3D([6301,5847,6184,6278],0); -ELEMENTS[42042] = Fluid3D([16053,16327,16414,15977],0); -ELEMENTS[42043] = Fluid3D([16414,16053,15977,15948],0); -ELEMENTS[42044] = Fluid3D([16053,15977,15948,15545],0); -ELEMENTS[42045] = Fluid3D([15977,15948,15545,16445],0); -ELEMENTS[42046] = Fluid3D([16414,16053,15948,16098],0); -ELEMENTS[42047] = Fluid3D([16053,16327,15977,15715],0); -ELEMENTS[42048] = Fluid3D([15977,16414,15948,16445],0); -ELEMENTS[42049] = Fluid3D([4044,3939,4321,3894],0); -ELEMENTS[42050] = Fluid3D([13492,13529,12837,13722],0); -ELEMENTS[42051] = Fluid3D([12284,12062,13052,12394],0); -ELEMENTS[42052] = Fluid3D([2926,3080,3126,3308],0); -ELEMENTS[42053] = Fluid3D([2926,3080,3308,3053],0); -ELEMENTS[42054] = Fluid3D([3080,3308,3053,3444],0); -ELEMENTS[42055] = Fluid3D([3080,3308,3444,3669],0); -ELEMENTS[42056] = Fluid3D([3080,3126,3308,3416],0); -ELEMENTS[42057] = Fluid3D([3308,3080,3416,3669],0); -ELEMENTS[42058] = Fluid3D([17752,17836,17650,18088],0); -ELEMENTS[42059] = Fluid3D([14516,15087,14592,14012],0); -ELEMENTS[42060] = Fluid3D([10066,10777,11022,10414],0); -ELEMENTS[42061] = Fluid3D([11291,11152,10439,10925],0); -ELEMENTS[42062] = Fluid3D([12610,11878,12357,11619],0); -ELEMENTS[42063] = Fluid3D([11391,10563,11613,10847],0); -ELEMENTS[42064] = Fluid3D([11000,10202,11104,10778],0); -ELEMENTS[42065] = Fluid3D([13325,12562,13251,13632],0); -ELEMENTS[42066] = Fluid3D([12427,13024,12578,11707],0); -ELEMENTS[42067] = Fluid3D([4791,4589,5155,4691],0); -ELEMENTS[42068] = Fluid3D([17058,16757,16699,16562],0); -ELEMENTS[42069] = Fluid3D([17058,16757,16562,17012],0); -ELEMENTS[42070] = Fluid3D([4882,4659,4570,4428],0); -ELEMENTS[42071] = Fluid3D([16807,17128,17247,16985],0); -ELEMENTS[42072] = Fluid3D([14901,14801,15445,15252],0); -ELEMENTS[42073] = Fluid3D([14316,14105,14881,14097],0); -ELEMENTS[42074] = Fluid3D([4943,5506,5535,5097],0); -ELEMENTS[42075] = Fluid3D([4950,5437,5546,5288],0); -ELEMENTS[42076] = Fluid3D([7850,8573,8509,7583],0); -ELEMENTS[42077] = Fluid3D([13738,13525,13850,12831],0); -ELEMENTS[42078] = Fluid3D([18608,18485,18518,18573],0); -ELEMENTS[42079] = Fluid3D([6370,6792,7171,6415],0); -ELEMENTS[42080] = Fluid3D([9362,8878,8752,8289],0); -ELEMENTS[42081] = Fluid3D([9990,10569,9649,9887],0); -ELEMENTS[42082] = Fluid3D([9990,10569,9887,10425],0); -ELEMENTS[42083] = Fluid3D([6180,6157,6911,6588],0); -ELEMENTS[42084] = Fluid3D([17273,16977,17237,16883],0); -ELEMENTS[42085] = Fluid3D([13352,13544,12762,13979],0); -ELEMENTS[42086] = Fluid3D([9811,9669,9531,8756],0); -ELEMENTS[42087] = Fluid3D([18098,18204,18287,18240],0); -ELEMENTS[42088] = Fluid3D([13963,13489,14176,13976],0); -ELEMENTS[42089] = Fluid3D([8182,8210,8209,7403],0); -ELEMENTS[42090] = Fluid3D([16717,16337,16193,16613],0); -ELEMENTS[42091] = Fluid3D([16337,16193,16613,15988],0); -ELEMENTS[42092] = Fluid3D([16193,16613,15988,16084],0); -ELEMENTS[42093] = Fluid3D([16193,16613,16084,16686],0); -ELEMENTS[42094] = Fluid3D([15988,16193,16084,15730],0); -ELEMENTS[42095] = Fluid3D([16193,16084,15730,16259],0); -ELEMENTS[42096] = Fluid3D([16613,15988,16084,16134],0); -ELEMENTS[42097] = Fluid3D([16337,16193,15988,15669],0); -ELEMENTS[42098] = Fluid3D([16193,16717,16613,16686],0); -ELEMENTS[42099] = Fluid3D([5585,5395,4969,4934],0); -ELEMENTS[42100] = Fluid3D([5807,6101,5864,6580],0); -ELEMENTS[42101] = Fluid3D([3233,3381,3692,3181],0); -ELEMENTS[42102] = Fluid3D([7465,7968,7407,7402],0); -ELEMENTS[42103] = Fluid3D([7407,7465,7402,6615],0); -ELEMENTS[42104] = Fluid3D([7402,7407,6615,6628],0); -ELEMENTS[42105] = Fluid3D([14976,14886,14971,14031],0); -ELEMENTS[42106] = Fluid3D([5796,5591,5737,5121],0); -ELEMENTS[42107] = Fluid3D([5366,4802,5057,5414],0); -ELEMENTS[42108] = Fluid3D([6583,6926,7185,6178],0); -ELEMENTS[42109] = Fluid3D([9217,9035,9945,8895],0); -ELEMENTS[42110] = Fluid3D([15686,15115,15434,14987],0); -ELEMENTS[42111] = Fluid3D([13487,12788,12669,12872],0); -ELEMENTS[42112] = Fluid3D([14244,14466,13664,14593],0); -ELEMENTS[42113] = Fluid3D([3148,3263,3295,2892],0); -ELEMENTS[42114] = Fluid3D([17512,17602,17732,17899],0); -ELEMENTS[42115] = Fluid3D([12575,12331,13138,12967],0); -ELEMENTS[42116] = Fluid3D([12575,12331,12967,12254],0); -ELEMENTS[42117] = Fluid3D([12331,12967,12254,13649],0); -ELEMENTS[42118] = Fluid3D([12967,12575,12254,12566],0); -ELEMENTS[42119] = Fluid3D([12254,12967,12566,12791],0); -ELEMENTS[42120] = Fluid3D([12254,12967,12791,13192],0); -ELEMENTS[42121] = Fluid3D([12967,12791,13192,13242],0); -ELEMENTS[42122] = Fluid3D([12791,13192,13242,12511],0); -ELEMENTS[42123] = Fluid3D([12791,13192,12511,12254],0); -ELEMENTS[42124] = Fluid3D([13242,12791,12511,11921],0); -ELEMENTS[42125] = Fluid3D([12791,12511,11921,12254],0); -ELEMENTS[42126] = Fluid3D([12967,12566,12791,13242],0); -ELEMENTS[42127] = Fluid3D([12967,12575,12566,13417],0); -ELEMENTS[42128] = Fluid3D([12566,12791,13242,11921],0); -ELEMENTS[42129] = Fluid3D([12566,12254,12791,11921],0); -ELEMENTS[42130] = Fluid3D([12566,12967,13417,13242],0); -ELEMENTS[42131] = Fluid3D([12254,12967,13192,12333],0); -ELEMENTS[42132] = Fluid3D([12254,12967,12333,12732],0); -ELEMENTS[42133] = Fluid3D([15710,16159,15802,15487],0); -ELEMENTS[42134] = Fluid3D([9701,9968,9770,11256],0); -ELEMENTS[42135] = Fluid3D([8795,9419,9710,8840],0); -ELEMENTS[42136] = Fluid3D([7263,6586,7026,6399],0); -ELEMENTS[42137] = Fluid3D([11398,10595,11432,11704],0); -ELEMENTS[42138] = Fluid3D([14599,14706,15268,14375],0); -ELEMENTS[42139] = Fluid3D([14934,14652,14150,14363],0); -ELEMENTS[42140] = Fluid3D([4481,4143,4543,4545],0); -ELEMENTS[42141] = Fluid3D([2688,2448,2594,2727],0); -ELEMENTS[42142] = Fluid3D([2594,2688,2727,2978],0); -ELEMENTS[42143] = Fluid3D([2688,2448,2727,2635],0); -ELEMENTS[42144] = Fluid3D([13992,14141,14456,13579],0); -ELEMENTS[42145] = Fluid3D([9901,10269,10872,10325],0); -ELEMENTS[42146] = Fluid3D([4215,4589,4791,4691],0); -ELEMENTS[42147] = Fluid3D([13879,13652,14518,14156],0); -ELEMENTS[42148] = Fluid3D([3314,3413,3725,3370],0); -ELEMENTS[42149] = Fluid3D([12640,12018,12646,11954],0); -ELEMENTS[42150] = Fluid3D([9021,8751,9104,9934],0); -ELEMENTS[42151] = Fluid3D([17268,17425,17662,17660],0); -ELEMENTS[42152] = Fluid3D([10854,10970,10059,10420],0); -ELEMENTS[42153] = Fluid3D([10059,10854,10420,10123],0); -ELEMENTS[42154] = Fluid3D([18230,18388,18213,18172],0); -ELEMENTS[42155] = Fluid3D([7340,7172,7907,7723],0); -ELEMENTS[42156] = Fluid3D([13456,12612,13027,13691],0); -ELEMENTS[42157] = Fluid3D([6924,7678,7127,7558],0); -ELEMENTS[42158] = Fluid3D([16452,16597,16112,16740],0); -ELEMENTS[42159] = Fluid3D([17750,17452,17573,17430],0); -ELEMENTS[42160] = Fluid3D([11963,12185,11429,11604],0); -ELEMENTS[42161] = Fluid3D([10147,10335,9353,10582],0); -ELEMENTS[42162] = Fluid3D([10147,10335,10582,11381],0); -ELEMENTS[42163] = Fluid3D([11038,12047,11499,11554],0); -ELEMENTS[42164] = Fluid3D([5947,5892,6530,6164],0); -ELEMENTS[42165] = Fluid3D([7041,6250,6559,6337],0); -ELEMENTS[42166] = Fluid3D([8877,8884,8612,7979],0); -ELEMENTS[42167] = Fluid3D([15100,14944,15186,15649],0); -ELEMENTS[42168] = Fluid3D([13813,14146,13533,13694],0); -ELEMENTS[42169] = Fluid3D([6308,6971,6679,7307],0); -ELEMENTS[42170] = Fluid3D([15787,16106,15697,16371],0); -ELEMENTS[42171] = Fluid3D([3124,3369,3406,3112],0); -ELEMENTS[42172] = Fluid3D([15188,15558,14910,15147],0); -ELEMENTS[42173] = Fluid3D([7692,8388,7578,8132],0); -ELEMENTS[42174] = Fluid3D([7691,7515,7536,8378],0); -ELEMENTS[42175] = Fluid3D([18387,18407,18208,18172],0); -ELEMENTS[42176] = Fluid3D([18407,18208,18172,18269],0); -ELEMENTS[42177] = Fluid3D([18208,18172,18269,17958],0); -ELEMENTS[42178] = Fluid3D([10479,11576,11271,11164],0); -ELEMENTS[42179] = Fluid3D([14926,15410,14717,15053],0); -ELEMENTS[42180] = Fluid3D([2026,2206,2167,2283],0); -ELEMENTS[42181] = Fluid3D([12190,12567,13073,11743],0); -ELEMENTS[42182] = Fluid3D([12190,12567,11743,11665],0); -ELEMENTS[42183] = Fluid3D([13185,13717,14132,13451],0); -ELEMENTS[42184] = Fluid3D([6069,6208,6520,5824],0); -ELEMENTS[42185] = Fluid3D([3237,3081,3206,2872],0); -ELEMENTS[42186] = Fluid3D([12806,13174,12111,12058],0); -ELEMENTS[42187] = Fluid3D([11842,11495,12452,11939],0); -ELEMENTS[42188] = Fluid3D([12731,13607,13331,13000],0); -ELEMENTS[42189] = Fluid3D([10965,10901,11603,11921],0); -ELEMENTS[42190] = Fluid3D([13765,13779,13092,13271],0); -ELEMENTS[42191] = Fluid3D([6316,6630,6014,5908],0); -ELEMENTS[42192] = Fluid3D([4180,4343,3768,4337],0); -ELEMENTS[42193] = Fluid3D([13175,13940,13604,14181],0); -ELEMENTS[42194] = Fluid3D([15407,15658,15813,16096],0); -ELEMENTS[42195] = Fluid3D([9411,8955,8453,9237],0); -ELEMENTS[42196] = Fluid3D([10292,9448,9451,9715],0); -ELEMENTS[42197] = Fluid3D([5243,5099,4997,5599],0); -ELEMENTS[42198] = Fluid3D([10851,10105,11096,10825],0); -ELEMENTS[42199] = Fluid3D([3202,2792,3248,3182],0); -ELEMENTS[42200] = Fluid3D([11875,11168,12241,11686],0); -ELEMENTS[42201] = Fluid3D([11239,10209,10605,10216],0); -ELEMENTS[42202] = Fluid3D([5152,5750,5335,5583],0); -ELEMENTS[42203] = Fluid3D([5152,5750,5583,5757],0); -ELEMENTS[42204] = Fluid3D([5750,5335,5583,6134],0); -ELEMENTS[42205] = Fluid3D([11505,11259,10911,12453],0); -ELEMENTS[42206] = Fluid3D([10193,10500,9581,10349],0); -ELEMENTS[42207] = Fluid3D([17139,17207,17334,17411],0); -ELEMENTS[42208] = Fluid3D([17139,17207,17411,17347],0); -ELEMENTS[42209] = Fluid3D([17334,17139,17411,17482],0); -ELEMENTS[42210] = Fluid3D([17139,17411,17482,17196],0); -ELEMENTS[42211] = Fluid3D([17139,17411,17196,17115],0); -ELEMENTS[42212] = Fluid3D([17139,17411,17115,17347],0); -ELEMENTS[42213] = Fluid3D([17196,17139,17115,16625],0); -ELEMENTS[42214] = Fluid3D([17482,17139,17196,16913],0); -ELEMENTS[42215] = Fluid3D([17334,17139,17482,16913],0); -ELEMENTS[42216] = Fluid3D([6313,6580,5807,5854],0); -ELEMENTS[42217] = Fluid3D([13183,12364,13011,12029],0); -ELEMENTS[42218] = Fluid3D([12886,12258,11974,12288],0); -ELEMENTS[42219] = Fluid3D([17902,17885,17634,17751],0); -ELEMENTS[42220] = Fluid3D([17634,17902,17751,17700],0); -ELEMENTS[42221] = Fluid3D([15936,16433,16365,15797],0); -ELEMENTS[42222] = Fluid3D([15970,15810,16407,15740],0); -ELEMENTS[42223] = Fluid3D([14299,14023,14872,14289],0); -ELEMENTS[42224] = Fluid3D([4606,4978,4416,4516],0); -ELEMENTS[42225] = Fluid3D([15582,15695,16203,16174],0); -ELEMENTS[42226] = Fluid3D([8507,9439,8858,8614],0); -ELEMENTS[42227] = Fluid3D([6761,7189,7148,7589],0); -ELEMENTS[42228] = Fluid3D([9904,10121,10889,10108],0); -ELEMENTS[42229] = Fluid3D([9904,10121,10108,9105],0); -ELEMENTS[42230] = Fluid3D([10108,9904,9105,9244],0); -ELEMENTS[42231] = Fluid3D([10108,9904,9244,10284],0); -ELEMENTS[42232] = Fluid3D([10108,9904,10284,11170],0); -ELEMENTS[42233] = Fluid3D([6949,6037,6543,6892],0); -ELEMENTS[42234] = Fluid3D([8334,7995,8415,7107],0); -ELEMENTS[42235] = Fluid3D([10753,11024,11612,11666],0); -ELEMENTS[42236] = Fluid3D([16400,16184,16064,15548],0); -ELEMENTS[42237] = Fluid3D([10264,9433,9338,9664],0); -ELEMENTS[42238] = Fluid3D([5249,5600,5169,5684],0); -ELEMENTS[42239] = Fluid3D([16574,16078,16280,16024],0); -ELEMENTS[42240] = Fluid3D([7706,8134,7509,8552],0); -ELEMENTS[42241] = Fluid3D([17673,17908,17786,17537],0); -ELEMENTS[42242] = Fluid3D([17673,17908,17537,17484],0); -ELEMENTS[42243] = Fluid3D([12144,12249,11310,12466],0); -ELEMENTS[42244] = Fluid3D([12043,11145,10862,11138],0); -ELEMENTS[42245] = Fluid3D([12043,11145,11138,10874],0); -ELEMENTS[42246] = Fluid3D([11145,11138,10874,10862],0); -ELEMENTS[42247] = Fluid3D([8542,9053,8764,8245],0); -ELEMENTS[42248] = Fluid3D([9053,8764,8245,8655],0); -ELEMENTS[42249] = Fluid3D([17379,17533,17470,17722],0); -ELEMENTS[42250] = Fluid3D([8987,9270,9574,10062],0); -ELEMENTS[42251] = Fluid3D([9773,9690,10566,10755],0); -ELEMENTS[42252] = Fluid3D([15389,15714,15423,15972],0); -ELEMENTS[42253] = Fluid3D([14960,15680,15434,15213],0); -ELEMENTS[42254] = Fluid3D([14666,13897,14294,14394],0); -ELEMENTS[42255] = Fluid3D([4816,5413,5328,5392],0); -ELEMENTS[42256] = Fluid3D([11044,10001,10347,10826],0); -ELEMENTS[42257] = Fluid3D([16698,16176,16342,16088],0); -ELEMENTS[42258] = Fluid3D([12059,11575,12499,12624],0); -ELEMENTS[42259] = Fluid3D([14712,15031,14859,15428],0); -ELEMENTS[42260] = Fluid3D([16172,16350,16490,16564],0); -ELEMENTS[42261] = Fluid3D([3551,3347,3128,3802],0); -ELEMENTS[42262] = Fluid3D([13217,13782,13933,13836],0); -ELEMENTS[42263] = Fluid3D([13782,13933,13836,14870],0); -ELEMENTS[42264] = Fluid3D([7277,8338,7591,8311],0); -ELEMENTS[42265] = Fluid3D([18026,17802,17796,17982],0); -ELEMENTS[42266] = Fluid3D([9361,8678,8735,9556],0); -ELEMENTS[42267] = Fluid3D([8735,9361,9556,9201],0); -ELEMENTS[42268] = Fluid3D([17307,17316,17040,17579],0); -ELEMENTS[42269] = Fluid3D([11774,12607,12507,12554],0); -ELEMENTS[42270] = Fluid3D([2146,2224,2197,1969],0); -ELEMENTS[42271] = Fluid3D([16695,16493,16649,17006],0); -ELEMENTS[42272] = Fluid3D([10245,10506,10931,11484],0); -ELEMENTS[42273] = Fluid3D([10931,10245,11484,10428],0); -ELEMENTS[42274] = Fluid3D([8886,8797,8074,8576],0); -ELEMENTS[42275] = Fluid3D([10994,11184,11371,11884],0); -ELEMENTS[42276] = Fluid3D([13079,12667,13534,13731],0); -ELEMENTS[42277] = Fluid3D([17910,17767,18053,18120],0); -ELEMENTS[42278] = Fluid3D([15656,15132,14864,15447],0); -ELEMENTS[42279] = Fluid3D([3772,3494,3431,4003],0); -ELEMENTS[42280] = Fluid3D([4449,4443,4414,4035],0); -ELEMENTS[42281] = Fluid3D([16007,15759,15775,15401],0); -ELEMENTS[42282] = Fluid3D([15759,15775,15401,15834],0); -ELEMENTS[42283] = Fluid3D([15775,16007,15401,15585],0); -ELEMENTS[42284] = Fluid3D([15775,15401,15834,15291],0); -ELEMENTS[42285] = Fluid3D([15775,15401,15291,15374],0); -ELEMENTS[42286] = Fluid3D([15775,15401,15374,15585],0); -ELEMENTS[42287] = Fluid3D([15401,15291,15374,14530],0); -ELEMENTS[42288] = Fluid3D([8218,8441,7886,7851],0); -ELEMENTS[42289] = Fluid3D([16517,16443,16540,16844],0); -ELEMENTS[42290] = Fluid3D([16517,16443,16844,17124],0); -ELEMENTS[42291] = Fluid3D([8367,7445,8032,8148],0); -ELEMENTS[42292] = Fluid3D([8367,7445,8148,7775],0); -ELEMENTS[42293] = Fluid3D([10368,10576,10461,11232],0); -ELEMENTS[42294] = Fluid3D([3819,3583,3947,3639],0); -ELEMENTS[42295] = Fluid3D([2135,2109,2384,2337],0); -ELEMENTS[42296] = Fluid3D([12831,11899,12432,12015],0); -ELEMENTS[42297] = Fluid3D([4590,4327,4911,4476],0); -ELEMENTS[42298] = Fluid3D([3488,3688,3221,3156],0); -ELEMENTS[42299] = Fluid3D([3221,3488,3156,3440],0); -ELEMENTS[42300] = Fluid3D([18008,18244,18117,18315],0); -ELEMENTS[42301] = Fluid3D([14529,14539,14528,13760],0); -ELEMENTS[42302] = Fluid3D([16219,16396,15969,15572],0); -ELEMENTS[42303] = Fluid3D([11129,11394,12124,11267],0); -ELEMENTS[42304] = Fluid3D([18374,18297,18178,18347],0); -ELEMENTS[42305] = Fluid3D([10986,11197,11890,11519],0); -ELEMENTS[42306] = Fluid3D([10755,11643,10817,10855],0); -ELEMENTS[42307] = Fluid3D([9709,9896,10089,10896],0); -ELEMENTS[42308] = Fluid3D([16097,16266,16608,16305],0); -ELEMENTS[42309] = Fluid3D([10506,9929,9514,10894],0); -ELEMENTS[42310] = Fluid3D([13464,14253,13954,13319],0); -ELEMENTS[42311] = Fluid3D([4463,3688,3816,3555],0); -ELEMENTS[42312] = Fluid3D([13617,12770,12787,13359],0); -ELEMENTS[42313] = Fluid3D([16915,16978,16960,16449],0); -ELEMENTS[42314] = Fluid3D([14147,13585,14393,14018],0); -ELEMENTS[42315] = Fluid3D([16113,16356,15957,16700],0); -ELEMENTS[42316] = Fluid3D([16668,16948,16806,16372],0); -ELEMENTS[42317] = Fluid3D([6019,6613,5913,6385],0); -ELEMENTS[42318] = Fluid3D([6613,5913,6385,6345],0); -ELEMENTS[42319] = Fluid3D([5913,6385,6345,5964],0); -ELEMENTS[42320] = Fluid3D([16602,16429,16589,15992],0); -ELEMENTS[42321] = Fluid3D([8917,9664,9796,9885],0); -ELEMENTS[42322] = Fluid3D([13805,14105,13179,13277],0); -ELEMENTS[42323] = Fluid3D([13179,13805,13277,12871],0); -ELEMENTS[42324] = Fluid3D([14105,13179,13277,13433],0); -ELEMENTS[42325] = Fluid3D([14798,14041,14049,14263],0); -ELEMENTS[42326] = Fluid3D([18520,18411,18363,18510],0); -ELEMENTS[42327] = Fluid3D([8189,7490,8509,7542],0); -ELEMENTS[42328] = Fluid3D([5239,4962,5377,4846],0); -ELEMENTS[42329] = Fluid3D([5377,5239,4846,5130],0); -ELEMENTS[42330] = Fluid3D([5239,4846,5130,4672],0); -ELEMENTS[42331] = Fluid3D([4846,5130,4672,4666],0); -ELEMENTS[42332] = Fluid3D([4672,4846,4666,4962],0); -ELEMENTS[42333] = Fluid3D([4846,5130,4666,5377],0); -ELEMENTS[42334] = Fluid3D([4666,4846,5377,4962],0); -ELEMENTS[42335] = Fluid3D([5239,4846,4672,4962],0); -ELEMENTS[42336] = Fluid3D([5128,5184,4811,4540],0); -ELEMENTS[42337] = Fluid3D([16369,16883,16527,16794],0); -ELEMENTS[42338] = Fluid3D([16597,16548,16025,16287],0); -ELEMENTS[42339] = Fluid3D([17943,18081,18098,17875],0); -ELEMENTS[42340] = Fluid3D([4343,4474,4883,4679],0); -ELEMENTS[42341] = Fluid3D([12620,12656,12141,11693],0); -ELEMENTS[42342] = Fluid3D([7007,7587,6729,6793],0); -ELEMENTS[42343] = Fluid3D([4094,3883,3625,4237],0); -ELEMENTS[42344] = Fluid3D([3883,3625,4237,3771],0); -ELEMENTS[42345] = Fluid3D([3883,3625,3771,3245],0); -ELEMENTS[42346] = Fluid3D([4237,3883,3771,4121],0); -ELEMENTS[42347] = Fluid3D([3625,4237,3771,3680],0); -ELEMENTS[42348] = Fluid3D([3771,3625,3680,3288],0); -ELEMENTS[42349] = Fluid3D([3771,3625,3288,3245],0); -ELEMENTS[42350] = Fluid3D([16193,15803,15824,15346],0); -ELEMENTS[42351] = Fluid3D([4303,3984,4625,4486],0); -ELEMENTS[42352] = Fluid3D([16792,16409,16697,16921],0); -ELEMENTS[42353] = Fluid3D([16697,16792,16921,17293],0); -ELEMENTS[42354] = Fluid3D([6615,6739,6259,5777],0); -ELEMENTS[42355] = Fluid3D([13119,13095,13811,13435],0); -ELEMENTS[42356] = Fluid3D([12921,12803,13586,13504],0); -ELEMENTS[42357] = Fluid3D([12921,12803,13504,12157],0); -ELEMENTS[42358] = Fluid3D([13586,12921,13504,13827],0); -ELEMENTS[42359] = Fluid3D([15507,15204,15099,14462],0); -ELEMENTS[42360] = Fluid3D([5421,5879,5777,6346],0); -ELEMENTS[42361] = Fluid3D([7143,6863,7488,8007],0); -ELEMENTS[42362] = Fluid3D([11913,12278,11445,11853],0); -ELEMENTS[42363] = Fluid3D([11445,11913,11853,11042],0); -ELEMENTS[42364] = Fluid3D([9458,8677,9017,8644],0); -ELEMENTS[42365] = Fluid3D([9017,9458,8644,9416],0); -ELEMENTS[42366] = Fluid3D([8644,9017,9416,9176],0); -ELEMENTS[42367] = Fluid3D([8644,9017,9176,8381],0); -ELEMENTS[42368] = Fluid3D([8644,9017,8381,7875],0); -ELEMENTS[42369] = Fluid3D([9176,8644,8381,8243],0); -ELEMENTS[42370] = Fluid3D([9416,8644,9176,9160],0); -ELEMENTS[42371] = Fluid3D([9017,9176,8381,9209],0); -ELEMENTS[42372] = Fluid3D([8381,9017,9209,8570],0); -ELEMENTS[42373] = Fluid3D([8381,9017,8570,7875],0); -ELEMENTS[42374] = Fluid3D([9209,8381,8570,8423],0); -ELEMENTS[42375] = Fluid3D([8381,8570,8423,7724],0); -ELEMENTS[42376] = Fluid3D([9017,9209,8570,9628],0); -ELEMENTS[42377] = Fluid3D([8570,8423,7724,8180],0); -ELEMENTS[42378] = Fluid3D([8423,7724,8180,7814],0); -ELEMENTS[42379] = Fluid3D([8180,8423,7814,9030],0); -ELEMENTS[42380] = Fluid3D([8570,8423,8180,9106],0); -ELEMENTS[42381] = Fluid3D([8423,8180,9106,9030],0); -ELEMENTS[42382] = Fluid3D([8423,7724,7814,8381],0); -ELEMENTS[42383] = Fluid3D([8570,8423,9106,9209],0); -ELEMENTS[42384] = Fluid3D([8423,9106,9209,9030],0); -ELEMENTS[42385] = Fluid3D([8381,8570,7724,7875],0); -ELEMENTS[42386] = Fluid3D([8570,7724,7875,7807],0); -ELEMENTS[42387] = Fluid3D([7724,7875,7807,7165],0); -ELEMENTS[42388] = Fluid3D([7875,7807,7165,7944],0); -ELEMENTS[42389] = Fluid3D([7807,7165,7944,7257],0); -ELEMENTS[42390] = Fluid3D([7807,7724,7165,7477],0); -ELEMENTS[42391] = Fluid3D([7165,7807,7477,7257],0); -ELEMENTS[42392] = Fluid3D([7875,7807,7944,8674],0); -ELEMENTS[42393] = Fluid3D([7807,7944,8674,8147],0); -ELEMENTS[42394] = Fluid3D([7807,7944,8147,7257],0); -ELEMENTS[42395] = Fluid3D([7944,8674,8147,8765],0); -ELEMENTS[42396] = Fluid3D([8674,7807,8147,8027],0); -ELEMENTS[42397] = Fluid3D([7807,8147,8027,7257],0); -ELEMENTS[42398] = Fluid3D([7807,7724,7477,8180],0); -ELEMENTS[42399] = Fluid3D([8674,7807,8027,8570],0); -ELEMENTS[42400] = Fluid3D([8674,7807,8570,7875],0); -ELEMENTS[42401] = Fluid3D([8570,8674,7875,9017],0); -ELEMENTS[42402] = Fluid3D([7724,8381,7875,7833],0); -ELEMENTS[42403] = Fluid3D([8570,8674,9017,9628],0); -ELEMENTS[42404] = Fluid3D([7944,8147,7257,8036],0); -ELEMENTS[42405] = Fluid3D([7944,8147,8036,8765],0); -ELEMENTS[42406] = Fluid3D([8570,8674,9628,8875],0); -ELEMENTS[42407] = Fluid3D([8570,7724,7807,8180],0); -ELEMENTS[42408] = Fluid3D([7724,8381,7833,7814],0); -ELEMENTS[42409] = Fluid3D([9209,8381,8423,8768],0); -ELEMENTS[42410] = Fluid3D([9209,8381,8768,9176],0); -ELEMENTS[42411] = Fluid3D([8381,8423,8768,7814],0); -ELEMENTS[42412] = Fluid3D([8423,9209,8768,9030],0); -ELEMENTS[42413] = Fluid3D([8768,8423,9030,7814],0); -ELEMENTS[42414] = Fluid3D([9106,8570,9209,9628],0); -ELEMENTS[42415] = Fluid3D([7807,8027,8570,8180],0); -ELEMENTS[42416] = Fluid3D([9017,9176,9209,10182],0); -ELEMENTS[42417] = Fluid3D([8381,7875,7833,8644],0); -ELEMENTS[42418] = Fluid3D([7833,8381,8644,8243],0); -ELEMENTS[42419] = Fluid3D([8381,8768,9176,8243],0); -ELEMENTS[42420] = Fluid3D([8768,9209,9176,9734],0); -ELEMENTS[42421] = Fluid3D([7724,7875,7165,7163],0); -ELEMENTS[42422] = Fluid3D([7724,7875,7163,7833],0); -ELEMENTS[42423] = Fluid3D([7163,7724,7833,7814],0); -ELEMENTS[42424] = Fluid3D([7165,7724,7163,6444],0); -ELEMENTS[42425] = Fluid3D([18019,17872,18147,17699],0); -ELEMENTS[42426] = Fluid3D([12658,12850,11887,12246],0); -ELEMENTS[42427] = Fluid3D([2594,2346,2518,2448],0); -ELEMENTS[42428] = Fluid3D([10902,11791,11692,11401],0); -ELEMENTS[42429] = Fluid3D([17656,17626,17275,17536],0); -ELEMENTS[42430] = Fluid3D([10488,9735,9588,9936],0); -ELEMENTS[42431] = Fluid3D([11315,10366,10780,11293],0); -ELEMENTS[42432] = Fluid3D([9190,8692,8737,9620],0); -ELEMENTS[42433] = Fluid3D([6411,7062,7005,6933],0); -ELEMENTS[42434] = Fluid3D([7005,6411,6933,6156],0); -ELEMENTS[42435] = Fluid3D([7062,7005,6933,7972],0); -ELEMENTS[42436] = Fluid3D([6933,7005,6156,6718],0); -ELEMENTS[42437] = Fluid3D([6933,7005,6718,7559],0); -ELEMENTS[42438] = Fluid3D([6718,6933,7559,7319],0); -ELEMENTS[42439] = Fluid3D([6933,7559,7319,7972],0); -ELEMENTS[42440] = Fluid3D([6933,7005,7559,7972],0); -ELEMENTS[42441] = Fluid3D([6718,6933,7319,6341],0); -ELEMENTS[42442] = Fluid3D([6718,6933,6341,6156],0); -ELEMENTS[42443] = Fluid3D([12383,12465,13175,12323],0); -ELEMENTS[42444] = Fluid3D([14599,13872,14706,14375],0); -ELEMENTS[42445] = Fluid3D([16622,16203,16174,16475],0); -ELEMENTS[42446] = Fluid3D([16174,16622,16475,16638],0); -ELEMENTS[42447] = Fluid3D([9086,9266,9770,8655],0); -ELEMENTS[42448] = Fluid3D([9770,9086,8655,9259],0); -ELEMENTS[42449] = Fluid3D([9086,8655,9259,9053],0); -ELEMENTS[42450] = Fluid3D([9086,9266,8655,8374],0); -ELEMENTS[42451] = Fluid3D([8655,9770,9259,9020],0); -ELEMENTS[42452] = Fluid3D([4813,5004,5108,5589],0); -ELEMENTS[42453] = Fluid3D([14888,15593,15226,14992],0); -ELEMENTS[42454] = Fluid3D([14845,13879,14686,14491],0); -ELEMENTS[42455] = Fluid3D([14845,13879,14491,14169],0); -ELEMENTS[42456] = Fluid3D([14686,14845,14491,15020],0); -ELEMENTS[42457] = Fluid3D([13879,14686,14491,14019],0); -ELEMENTS[42458] = Fluid3D([4340,4572,4267,3945],0); -ELEMENTS[42459] = Fluid3D([8224,8256,7839,7511],0); -ELEMENTS[42460] = Fluid3D([10946,10452,11479,11033],0); -ELEMENTS[42461] = Fluid3D([10452,11479,11033,10494],0); -ELEMENTS[42462] = Fluid3D([18213,18417,18207,18296],0); -ELEMENTS[42463] = Fluid3D([18213,18417,18296,18388],0); -ELEMENTS[42464] = Fluid3D([18207,18213,18296,18062],0); -ELEMENTS[42465] = Fluid3D([3941,4086,4144,4226],0); -ELEMENTS[42466] = Fluid3D([4144,3941,4226,4240],0); -ELEMENTS[42467] = Fluid3D([3941,4226,4240,3741],0); -ELEMENTS[42468] = Fluid3D([3941,4226,3741,3622],0); -ELEMENTS[42469] = Fluid3D([3941,4086,4226,3934],0); -ELEMENTS[42470] = Fluid3D([8536,7868,8591,9073],0); -ELEMENTS[42471] = Fluid3D([8591,8536,9073,9788],0); -ELEMENTS[42472] = Fluid3D([6150,6906,6406,6443],0); -ELEMENTS[42473] = Fluid3D([7087,7967,7466,7866],0); -ELEMENTS[42474] = Fluid3D([2812,3076,3210,3159],0); -ELEMENTS[42475] = Fluid3D([2812,3076,3159,2710],0); -ELEMENTS[42476] = Fluid3D([3076,3210,3159,3503],0); -ELEMENTS[42477] = Fluid3D([3159,3076,3503,3298],0); -ELEMENTS[42478] = Fluid3D([3076,3210,3503,3226],0); -ELEMENTS[42479] = Fluid3D([11579,12321,11742,12436],0); -ELEMENTS[42480] = Fluid3D([10590,10800,10580,9801],0); -ELEMENTS[42481] = Fluid3D([18241,18391,18248,18451],0); -ELEMENTS[42482] = Fluid3D([5786,5658,6335,5751],0); -ELEMENTS[42483] = Fluid3D([9287,8347,8803,8979],0); -ELEMENTS[42484] = Fluid3D([13657,13633,14075,12876],0); -ELEMENTS[42485] = Fluid3D([5485,5304,5821,5394],0); -ELEMENTS[42486] = Fluid3D([15770,16186,15790,16358],0); -ELEMENTS[42487] = Fluid3D([15178,15514,14904,15394],0); -ELEMENTS[42488] = Fluid3D([4439,4445,4029,4092],0); -ELEMENTS[42489] = Fluid3D([12352,13100,13227,12814],0); -ELEMENTS[42490] = Fluid3D([8629,7910,7842,8469],0); -ELEMENTS[42491] = Fluid3D([6779,6524,5872,6192],0); -ELEMENTS[42492] = Fluid3D([14063,14426,14445,13718],0); -ELEMENTS[42493] = Fluid3D([2957,3338,3107,3132],0); -ELEMENTS[42494] = Fluid3D([5657,6256,5922,5428],0); -ELEMENTS[42495] = Fluid3D([9661,10215,10260,9491],0); -ELEMENTS[42496] = Fluid3D([16119,15515,16282,16099],0); -ELEMENTS[42497] = Fluid3D([10927,11005,10132,10943],0); -ELEMENTS[42498] = Fluid3D([17280,16772,17120,16994],0); -ELEMENTS[42499] = Fluid3D([17120,17280,16994,17480],0); -ELEMENTS[42500] = Fluid3D([17280,16994,17480,17639],0); -ELEMENTS[42501] = Fluid3D([17120,17280,17480,17576],0); -ELEMENTS[42502] = Fluid3D([17480,17120,17576,17033],0); -ELEMENTS[42503] = Fluid3D([17280,17480,17576,17609],0); -ELEMENTS[42504] = Fluid3D([17280,16772,16994,17181],0); -ELEMENTS[42505] = Fluid3D([16994,17280,17181,17639],0); -ELEMENTS[42506] = Fluid3D([16994,17120,17480,17033],0); -ELEMENTS[42507] = Fluid3D([17480,17576,17609,17817],0); -ELEMENTS[42508] = Fluid3D([17480,17576,17817,17742],0); -ELEMENTS[42509] = Fluid3D([17480,17576,17742,17033],0); -ELEMENTS[42510] = Fluid3D([12092,11509,11562,11228],0); -ELEMENTS[42511] = Fluid3D([12740,12320,12182,13022],0); -ELEMENTS[42512] = Fluid3D([12740,12320,13022,13279],0); -ELEMENTS[42513] = Fluid3D([11345,10653,10304,11049],0); -ELEMENTS[42514] = Fluid3D([10653,10304,11049,9996],0); -ELEMENTS[42515] = Fluid3D([11049,10653,9996,10836],0); -ELEMENTS[42516] = Fluid3D([11049,10653,10836,11740],0); -ELEMENTS[42517] = Fluid3D([10653,10304,9996,9457],0); -ELEMENTS[42518] = Fluid3D([9996,10653,9457,10836],0); -ELEMENTS[42519] = Fluid3D([9996,11049,10836,10732],0); -ELEMENTS[42520] = Fluid3D([10836,11049,11740,11642],0); -ELEMENTS[42521] = Fluid3D([10836,11049,11642,10732],0); -ELEMENTS[42522] = Fluid3D([11049,11740,11642,12523],0); -ELEMENTS[42523] = Fluid3D([11345,10653,11049,11740],0); -ELEMENTS[42524] = Fluid3D([13745,13629,14453,13832],0); -ELEMENTS[42525] = Fluid3D([14453,13745,13832,14735],0); -ELEMENTS[42526] = Fluid3D([13745,13629,13832,12847],0); -ELEMENTS[42527] = Fluid3D([13832,13745,12847,13206],0); -ELEMENTS[42528] = Fluid3D([13832,13745,13206,14174],0); -ELEMENTS[42529] = Fluid3D([13832,13745,14174,14735],0); -ELEMENTS[42530] = Fluid3D([12377,12923,13274,13369],0); -ELEMENTS[42531] = Fluid3D([17740,17481,17352,17257],0); -ELEMENTS[42532] = Fluid3D([4334,3934,4244,4527],0); -ELEMENTS[42533] = Fluid3D([8228,8598,9062,8910],0); -ELEMENTS[42534] = Fluid3D([14810,14162,15088,14768],0); -ELEMENTS[42535] = Fluid3D([11905,11811,11023,11417],0); -ELEMENTS[42536] = Fluid3D([14632,14578,14458,13839],0); -ELEMENTS[42537] = Fluid3D([14632,14578,13839,14252],0); -ELEMENTS[42538] = Fluid3D([15401,14755,15163,14470],0); -ELEMENTS[42539] = Fluid3D([3547,3205,3433,3570],0); -ELEMENTS[42540] = Fluid3D([2865,2666,2987,2783],0); -ELEMENTS[42541] = Fluid3D([7627,7158,8089,6894],0); -ELEMENTS[42542] = Fluid3D([8607,7882,8878,8289],0); -ELEMENTS[42543] = Fluid3D([16720,16931,17188,17178],0); -ELEMENTS[42544] = Fluid3D([15030,15320,14539,14769],0); -ELEMENTS[42545] = Fluid3D([15030,15320,14769,15285],0); -ELEMENTS[42546] = Fluid3D([14539,15030,14769,14066],0); -ELEMENTS[42547] = Fluid3D([12540,12998,12002,12026],0); -ELEMENTS[42548] = Fluid3D([12654,13011,12007,12721],0); -ELEMENTS[42549] = Fluid3D([18405,18529,18463,18444],0); -ELEMENTS[42550] = Fluid3D([16020,15527,16197,15692],0); -ELEMENTS[42551] = Fluid3D([10290,10252,9677,10624],0); -ELEMENTS[42552] = Fluid3D([17123,16895,16857,17296],0); -ELEMENTS[42553] = Fluid3D([4485,4534,4731,5047],0); -ELEMENTS[42554] = Fluid3D([9565,9055,10073,10245],0); -ELEMENTS[42555] = Fluid3D([9385,9620,9965,10855],0); -ELEMENTS[42556] = Fluid3D([14867,14319,14255,14564],0); -ELEMENTS[42557] = Fluid3D([15055,14569,15181,14140],0); -ELEMENTS[42558] = Fluid3D([12957,12271,12772,12389],0); -ELEMENTS[42559] = Fluid3D([5879,5965,5530,5311],0); -ELEMENTS[42560] = Fluid3D([14786,14547,15260,15004],0); -ELEMENTS[42561] = Fluid3D([6626,7306,7149,6315],0); -ELEMENTS[42562] = Fluid3D([7820,8566,8164,7706],0); -ELEMENTS[42563] = Fluid3D([12312,12519,11620,11442],0); -ELEMENTS[42564] = Fluid3D([18346,18309,18179,18367],0); -ELEMENTS[42565] = Fluid3D([15700,15231,14946,15476],0); -ELEMENTS[42566] = Fluid3D([9804,9590,8776,9140],0); -ELEMENTS[42567] = Fluid3D([17447,17056,17146,16891],0); -ELEMENTS[42568] = Fluid3D([17056,17146,16891,16723],0); -ELEMENTS[42569] = Fluid3D([17447,17056,16891,17164],0); -ELEMENTS[42570] = Fluid3D([5952,6156,5508,5535],0); -ELEMENTS[42571] = Fluid3D([10819,11189,10755,9933],0); -ELEMENTS[42572] = Fluid3D([12207,11839,12818,12264],0); -ELEMENTS[42573] = Fluid3D([5358,5634,5738,5192],0); -ELEMENTS[42574] = Fluid3D([14076,13192,13581,13354],0); -ELEMENTS[42575] = Fluid3D([13192,13581,13354,12732],0); -ELEMENTS[42576] = Fluid3D([13581,13354,12732,13707],0); -ELEMENTS[42577] = Fluid3D([13354,12732,13707,13334],0); -ELEMENTS[42578] = Fluid3D([13581,13354,13707,14076],0); -ELEMENTS[42579] = Fluid3D([13354,13707,14076,14410],0); -ELEMENTS[42580] = Fluid3D([13354,13192,12732,12950],0); -ELEMENTS[42581] = Fluid3D([13354,13192,12950,14076],0); -ELEMENTS[42582] = Fluid3D([4385,4311,4408,4899],0); -ELEMENTS[42583] = Fluid3D([15427,15187,15598,15734],0); -ELEMENTS[42584] = Fluid3D([16120,15867,15691,16265],0); -ELEMENTS[42585] = Fluid3D([10359,10774,10632,9551],0); -ELEMENTS[42586] = Fluid3D([17383,16915,16960,17177],0); -ELEMENTS[42587] = Fluid3D([11914,12162,11714,12947],0); -ELEMENTS[42588] = Fluid3D([14423,13883,13736,13739],0); -ELEMENTS[42589] = Fluid3D([14423,13883,13739,14481],0); -ELEMENTS[42590] = Fluid3D([13736,14423,13739,13842],0); -ELEMENTS[42591] = Fluid3D([13634,13692,14524,14034],0); -ELEMENTS[42592] = Fluid3D([13634,13692,14034,13155],0); -ELEMENTS[42593] = Fluid3D([14034,13634,13155,12870],0); -ELEMENTS[42594] = Fluid3D([14524,13634,14034,14312],0); -ELEMENTS[42595] = Fluid3D([13634,14034,14312,13608],0); -ELEMENTS[42596] = Fluid3D([14034,14312,13608,14378],0); -ELEMENTS[42597] = Fluid3D([14312,13634,13608,14131],0); -ELEMENTS[42598] = Fluid3D([12521,12025,11639,12121],0); -ELEMENTS[42599] = Fluid3D([7579,7839,6951,7511],0); -ELEMENTS[42600] = Fluid3D([3347,3387,3069,3128],0); -ELEMENTS[42601] = Fluid3D([8883,8425,9279,9082],0); -ELEMENTS[42602] = Fluid3D([18188,17929,18152,18163],0); -ELEMENTS[42603] = Fluid3D([17824,17782,17743,17533],0); -ELEMENTS[42604] = Fluid3D([17824,17782,17533,17616],0); -ELEMENTS[42605] = Fluid3D([17533,17824,17616,17469],0); -ELEMENTS[42606] = Fluid3D([17782,17533,17616,17720],0); -ELEMENTS[42607] = Fluid3D([17782,17743,17533,17470],0); -ELEMENTS[42608] = Fluid3D([17533,17782,17470,17722],0); -ELEMENTS[42609] = Fluid3D([17533,17782,17722,17720],0); -ELEMENTS[42610] = Fluid3D([17782,17470,17722,17787],0); -ELEMENTS[42611] = Fluid3D([17533,17824,17469,17743],0); -ELEMENTS[42612] = Fluid3D([17782,17722,17720,18063],0); -ELEMENTS[42613] = Fluid3D([17782,17722,18063,18038],0); -ELEMENTS[42614] = Fluid3D([17469,17533,17743,17470],0); -ELEMENTS[42615] = Fluid3D([7996,8441,9000,8247],0); -ELEMENTS[42616] = Fluid3D([7900,7852,8245,8764],0); -ELEMENTS[42617] = Fluid3D([7900,7852,8764,8044],0); -ELEMENTS[42618] = Fluid3D([15616,15900,15841,15145],0); -ELEMENTS[42619] = Fluid3D([7726,8628,8466,8120],0); -ELEMENTS[42620] = Fluid3D([8628,8466,8120,9046],0); -ELEMENTS[42621] = Fluid3D([6139,5652,6189,5941],0); -ELEMENTS[42622] = Fluid3D([9806,9226,9943,8897],0); -ELEMENTS[42623] = Fluid3D([6110,5902,5976,5319],0); -ELEMENTS[42624] = Fluid3D([15281,15219,15563,15928],0); -ELEMENTS[42625] = Fluid3D([12933,13285,13196,12390],0); -ELEMENTS[42626] = Fluid3D([7333,7612,7339,6534],0); -ELEMENTS[42627] = Fluid3D([2385,2288,2186,2109],0); -ELEMENTS[42628] = Fluid3D([15346,14613,15054,14749],0); -ELEMENTS[42629] = Fluid3D([3106,3208,3178,2823],0); -ELEMENTS[42630] = Fluid3D([4881,5267,5468,5030],0); -ELEMENTS[42631] = Fluid3D([15458,16018,15911,15514],0); -ELEMENTS[42632] = Fluid3D([3809,4307,4195,4251],0); -ELEMENTS[42633] = Fluid3D([16330,16418,16251,15914],0); -ELEMENTS[42634] = Fluid3D([12889,13194,12519,13371],0); -ELEMENTS[42635] = Fluid3D([13194,12519,13371,13749],0); -ELEMENTS[42636] = Fluid3D([12889,13194,13371,13952],0); -ELEMENTS[42637] = Fluid3D([11086,11226,11860,11395],0); -ELEMENTS[42638] = Fluid3D([16599,16786,16918,17219],0); -ELEMENTS[42639] = Fluid3D([11095,11473,11899,10552],0); -ELEMENTS[42640] = Fluid3D([8790,8348,7970,8634],0); -ELEMENTS[42641] = Fluid3D([2444,2652,2483,2298],0); -ELEMENTS[42642] = Fluid3D([2483,2444,2298,2163],0); -ELEMENTS[42643] = Fluid3D([14234,14581,14603,13741],0); -ELEMENTS[42644] = Fluid3D([18044,18067,17974,18280],0); -ELEMENTS[42645] = Fluid3D([11812,11731,12024,12710],0); -ELEMENTS[42646] = Fluid3D([12413,13288,12623,13037],0); -ELEMENTS[42647] = Fluid3D([5062,5431,4973,4762],0); -ELEMENTS[42648] = Fluid3D([9132,8722,8270,9259],0); -ELEMENTS[42649] = Fluid3D([11821,11878,12610,11619],0); -ELEMENTS[42650] = Fluid3D([11317,12163,11373,11241],0); -ELEMENTS[42651] = Fluid3D([14216,13951,14796,14280],0); -ELEMENTS[42652] = Fluid3D([13951,14796,14280,14068],0); -ELEMENTS[42653] = Fluid3D([14216,13951,14280,13274],0); -ELEMENTS[42654] = Fluid3D([12127,11970,11524,11064],0); -ELEMENTS[42655] = Fluid3D([17346,17351,17669,17386],0); -ELEMENTS[42656] = Fluid3D([17346,17351,17386,16932],0); -ELEMENTS[42657] = Fluid3D([12017,11007,11175,11872],0); -ELEMENTS[42658] = Fluid3D([5013,4620,4639,4452],0); -ELEMENTS[42659] = Fluid3D([4639,5013,4452,4359],0); -ELEMENTS[42660] = Fluid3D([4452,4639,4359,4090],0); -ELEMENTS[42661] = Fluid3D([4359,4452,4090,4008],0); -ELEMENTS[42662] = Fluid3D([4359,4452,4008,4415],0); -ELEMENTS[42663] = Fluid3D([4452,4090,4008,3957],0); -ELEMENTS[42664] = Fluid3D([4090,4359,4008,3560],0); -ELEMENTS[42665] = Fluid3D([4008,4452,3957,4193],0); -ELEMENTS[42666] = Fluid3D([3957,4008,4193,3676],0); -ELEMENTS[42667] = Fluid3D([3957,4008,3676,4090],0); -ELEMENTS[42668] = Fluid3D([4008,3676,4090,3560],0); -ELEMENTS[42669] = Fluid3D([3676,3957,4090,4107],0); -ELEMENTS[42670] = Fluid3D([4452,4639,4090,4620],0); -ELEMENTS[42671] = Fluid3D([5013,4620,4452,4843],0); -ELEMENTS[42672] = Fluid3D([4452,5013,4843,4359],0); -ELEMENTS[42673] = Fluid3D([4843,4452,4359,4415],0); -ELEMENTS[42674] = Fluid3D([4843,4452,4415,4193],0); -ELEMENTS[42675] = Fluid3D([4008,4452,4193,4415],0); -ELEMENTS[42676] = Fluid3D([4193,4008,4415,3874],0); -ELEMENTS[42677] = Fluid3D([4639,4359,4090,3826],0); -ELEMENTS[42678] = Fluid3D([15816,15464,15140,15480],0); -ELEMENTS[42679] = Fluid3D([15140,15816,15480,15297],0); -ELEMENTS[42680] = Fluid3D([12372,13038,13306,13403],0); -ELEMENTS[42681] = Fluid3D([16077,15984,16410,16074],0); -ELEMENTS[42682] = Fluid3D([3949,3799,4159,3497],0); -ELEMENTS[42683] = Fluid3D([13462,13644,14305,13844],0); -ELEMENTS[42684] = Fluid3D([13433,13855,14105,13179],0); -ELEMENTS[42685] = Fluid3D([5021,4776,4734,4266],0); -ELEMENTS[42686] = Fluid3D([14192,13355,13708,13221],0); -ELEMENTS[42687] = Fluid3D([18130,18252,18363,18287],0); -ELEMENTS[42688] = Fluid3D([11946,11788,12255,12707],0); -ELEMENTS[42689] = Fluid3D([9336,9633,10313,9093],0); -ELEMENTS[42690] = Fluid3D([7124,7880,7148,7189],0); -ELEMENTS[42691] = Fluid3D([9307,10093,9095,8850],0); -ELEMENTS[42692] = Fluid3D([16904,16602,16589,17055],0); -ELEMENTS[42693] = Fluid3D([11233,10511,10600,11350],0); -ELEMENTS[42694] = Fluid3D([6318,6463,6836,5758],0); -ELEMENTS[42695] = Fluid3D([11439,10809,11012,10268],0); -ELEMENTS[42696] = Fluid3D([11439,10809,10268,10746],0); -ELEMENTS[42697] = Fluid3D([10809,10268,10746,9928],0); -ELEMENTS[42698] = Fluid3D([10809,10268,9928,10087],0); -ELEMENTS[42699] = Fluid3D([10746,10809,9928,9886],0); -ELEMENTS[42700] = Fluid3D([9928,10746,9886,9705],0); -ELEMENTS[42701] = Fluid3D([9886,9928,9705,9175],0); -ELEMENTS[42702] = Fluid3D([9928,9705,9175,10268],0); -ELEMENTS[42703] = Fluid3D([9705,9886,9175,9924],0); -ELEMENTS[42704] = Fluid3D([9175,9705,9924,10043],0); -ELEMENTS[42705] = Fluid3D([9705,9924,10043,10746],0); -ELEMENTS[42706] = Fluid3D([9175,9705,10043,9552],0); -ELEMENTS[42707] = Fluid3D([9175,9705,9552,10268],0); -ELEMENTS[42708] = Fluid3D([9705,9886,9924,10746],0); -ELEMENTS[42709] = Fluid3D([9705,10043,9552,10268],0); -ELEMENTS[42710] = Fluid3D([9928,10746,9705,10268],0); -ELEMENTS[42711] = Fluid3D([18653,18603,18617,18571],0); -ELEMENTS[42712] = Fluid3D([9601,9713,8947,9712],0); -ELEMENTS[42713] = Fluid3D([9713,8947,9712,9392],0); -ELEMENTS[42714] = Fluid3D([8978,9207,9853,8734],0); -ELEMENTS[42715] = Fluid3D([12472,12421,13291,12711],0); -ELEMENTS[42716] = Fluid3D([14266,13929,14425,15018],0); -ELEMENTS[42717] = Fluid3D([4544,4672,4089,4516],0); -ELEMENTS[42718] = Fluid3D([11946,11305,11084,12112],0); -ELEMENTS[42719] = Fluid3D([8685,9552,9476,8683],0); -ELEMENTS[42720] = Fluid3D([9309,9601,8955,8475],0); -ELEMENTS[42721] = Fluid3D([7732,8070,7466,7359],0); -ELEMENTS[42722] = Fluid3D([7732,8070,7359,7716],0); -ELEMENTS[42723] = Fluid3D([7359,7732,7716,6902],0); -ELEMENTS[42724] = Fluid3D([7466,7732,7359,6842],0); -ELEMENTS[42725] = Fluid3D([16759,17131,17084,16676],0); -ELEMENTS[42726] = Fluid3D([5679,5793,6017,5670],0); -ELEMENTS[42727] = Fluid3D([5793,6017,5670,6209],0); -ELEMENTS[42728] = Fluid3D([5670,5793,6209,5598],0); -ELEMENTS[42729] = Fluid3D([5971,6460,5966,5536],0); -ELEMENTS[42730] = Fluid3D([15045,15210,15251,14509],0); -ELEMENTS[42731] = Fluid3D([6750,6277,6900,6968],0); -ELEMENTS[42732] = Fluid3D([16576,16030,16192,16155],0); -ELEMENTS[42733] = Fluid3D([16192,16576,16155,16889],0); -ELEMENTS[42734] = Fluid3D([16030,16192,16155,15600],0); -ELEMENTS[42735] = Fluid3D([7113,7393,6809,6174],0); -ELEMENTS[42736] = Fluid3D([11849,12274,12669,11781],0); -ELEMENTS[42737] = Fluid3D([4810,4684,5267,4743],0); -ELEMENTS[42738] = Fluid3D([1791,1723,1712,1621],0); -ELEMENTS[42739] = Fluid3D([18243,18282,18014,18191],0); -ELEMENTS[42740] = Fluid3D([7809,7026,7582,7599],0); -ELEMENTS[42741] = Fluid3D([4930,4468,4448,4425],0); -ELEMENTS[42742] = Fluid3D([14742,15459,14939,15163],0); -ELEMENTS[42743] = Fluid3D([14742,15459,15163,14933],0); -ELEMENTS[42744] = Fluid3D([14939,14742,15163,14779],0); -ELEMENTS[42745] = Fluid3D([14939,14742,14779,14209],0); -ELEMENTS[42746] = Fluid3D([14939,14742,14209,14730],0); -ELEMENTS[42747] = Fluid3D([14939,14742,14730,15196],0); -ELEMENTS[42748] = Fluid3D([14742,14209,14730,14033],0); -ELEMENTS[42749] = Fluid3D([14209,14939,14730,14487],0); -ELEMENTS[42750] = Fluid3D([14730,14209,14487,14033],0); -ELEMENTS[42751] = Fluid3D([14939,14730,14487,15196],0); -ELEMENTS[42752] = Fluid3D([14209,14939,14487,14184],0); -ELEMENTS[42753] = Fluid3D([14730,14487,15196,14579],0); -ELEMENTS[42754] = Fluid3D([15196,14730,14579,14854],0); -ELEMENTS[42755] = Fluid3D([15196,14730,14854,14742],0); -ELEMENTS[42756] = Fluid3D([14730,14854,14742,14033],0); -ELEMENTS[42757] = Fluid3D([14487,14209,14184,13263],0); -ELEMENTS[42758] = Fluid3D([14730,14854,14033,14579],0); -ELEMENTS[42759] = Fluid3D([14033,14730,14579,14487],0); -ELEMENTS[42760] = Fluid3D([14854,14033,14579,14715],0); -ELEMENTS[42761] = Fluid3D([14706,15137,15268,15312],0); -ELEMENTS[42762] = Fluid3D([15268,14706,15312,14478],0); -ELEMENTS[42763] = Fluid3D([2635,2453,2448,2477],0); -ELEMENTS[42764] = Fluid3D([2448,2635,2477,2727],0); -ELEMENTS[42765] = Fluid3D([14027,13264,13566,13754],0); -ELEMENTS[42766] = Fluid3D([12770,11857,12149,12779],0); -ELEMENTS[42767] = Fluid3D([14341,13775,13545,13989],0); -ELEMENTS[42768] = Fluid3D([7062,7629,7180,8217],0); -ELEMENTS[42769] = Fluid3D([7753,7973,8613,8850],0); -ELEMENTS[42770] = Fluid3D([15856,16513,16227,16000],0); -ELEMENTS[42771] = Fluid3D([12326,13109,12711,11832],0); -ELEMENTS[42772] = Fluid3D([10629,10152,10970,9903],0); -ELEMENTS[42773] = Fluid3D([16339,16452,15881,16029],0); -ELEMENTS[42774] = Fluid3D([16155,16203,16683,16306],0); -ELEMENTS[42775] = Fluid3D([16203,16683,16306,16475],0); -ELEMENTS[42776] = Fluid3D([16155,16203,16306,15582],0); -ELEMENTS[42777] = Fluid3D([7558,6941,6790,7584],0); -ELEMENTS[42778] = Fluid3D([6496,7218,7308,6750],0); -ELEMENTS[42779] = Fluid3D([11062,11963,11796,10711],0); -ELEMENTS[42780] = Fluid3D([12438,11881,12035,13046],0); -ELEMENTS[42781] = Fluid3D([17113,17244,17236,17432],0); -ELEMENTS[42782] = Fluid3D([17113,17244,17432,17443],0); -ELEMENTS[42783] = Fluid3D([7663,7422,7375,8057],0); -ELEMENTS[42784] = Fluid3D([7375,7663,8057,7771],0); -ELEMENTS[42785] = Fluid3D([12085,11483,11413,11710],0); -ELEMENTS[42786] = Fluid3D([6111,6292,5576,6131],0); -ELEMENTS[42787] = Fluid3D([3842,3908,3518,3592],0); -ELEMENTS[42788] = Fluid3D([13641,13954,13753,12878],0); -ELEMENTS[42789] = Fluid3D([13222,12531,12981,12149],0); -ELEMENTS[42790] = Fluid3D([6044,6052,6742,6766],0); -ELEMENTS[42791] = Fluid3D([14595,14938,14943,13995],0); -ELEMENTS[42792] = Fluid3D([2740,2943,2713,2512],0); -ELEMENTS[42793] = Fluid3D([13536,14383,14138,13810],0); -ELEMENTS[42794] = Fluid3D([6082,6076,5468,5769],0); -ELEMENTS[42795] = Fluid3D([3018,2914,2844,2738],0); -ELEMENTS[42796] = Fluid3D([17520,17497,17485,17073],0); -ELEMENTS[42797] = Fluid3D([17520,17497,17073,17225],0); -ELEMENTS[42798] = Fluid3D([13323,12589,12560,13303],0); -ELEMENTS[42799] = Fluid3D([12560,13323,13303,13790],0); -ELEMENTS[42800] = Fluid3D([2978,3138,2760,2700],0); -ELEMENTS[42801] = Fluid3D([3965,3848,4306,3886],0); -ELEMENTS[42802] = Fluid3D([6803,7567,7693,6800],0); -ELEMENTS[42803] = Fluid3D([6803,7567,6800,6627],0); -ELEMENTS[42804] = Fluid3D([7567,7693,6800,7523],0); -ELEMENTS[42805] = Fluid3D([7567,7693,7523,8447],0); -ELEMENTS[42806] = Fluid3D([6800,7567,7523,6627],0); -ELEMENTS[42807] = Fluid3D([7523,7567,8447,8043],0); -ELEMENTS[42808] = Fluid3D([7693,6803,6800,6959],0); -ELEMENTS[42809] = Fluid3D([6803,6800,6959,6133],0); -ELEMENTS[42810] = Fluid3D([6803,6800,6133,5984],0); -ELEMENTS[42811] = Fluid3D([7567,7693,8447,8305],0); -ELEMENTS[42812] = Fluid3D([15637,15535,15022,15633],0); -ELEMENTS[42813] = Fluid3D([15637,15535,15633,16134],0); -ELEMENTS[42814] = Fluid3D([15022,15637,15633,15346],0); -ELEMENTS[42815] = Fluid3D([9877,10391,9855,9178],0); -ELEMENTS[42816] = Fluid3D([9985,9779,9982,9107],0); -ELEMENTS[42817] = Fluid3D([13040,12275,12732,12735],0); -ELEMENTS[42818] = Fluid3D([12275,12732,12735,12331],0); -ELEMENTS[42819] = Fluid3D([12732,12735,12331,13649],0); -ELEMENTS[42820] = Fluid3D([12735,12331,13649,13041],0); -ELEMENTS[42821] = Fluid3D([12735,12331,13041,11917],0); -ELEMENTS[42822] = Fluid3D([12735,12331,11917,12275],0); -ELEMENTS[42823] = Fluid3D([13649,12735,13041,13040],0); -ELEMENTS[42824] = Fluid3D([13649,12735,13040,12732],0); -ELEMENTS[42825] = Fluid3D([11917,12735,12275,13041],0); -ELEMENTS[42826] = Fluid3D([13040,12275,12735,13041],0); -ELEMENTS[42827] = Fluid3D([17576,17825,17454,17609],0); -ELEMENTS[42828] = Fluid3D([11942,11663,12627,12023],0); -ELEMENTS[42829] = Fluid3D([7550,7907,8069,7041],0); -ELEMENTS[42830] = Fluid3D([10205,11009,11104,11238],0); -ELEMENTS[42831] = Fluid3D([11104,10205,11238,10322],0); -ELEMENTS[42832] = Fluid3D([13089,12179,12518,12514],0); -ELEMENTS[42833] = Fluid3D([10698,11042,11419,11445],0); -ELEMENTS[42834] = Fluid3D([17013,17177,16698,16915],0); -ELEMENTS[42835] = Fluid3D([2860,2572,2538,2680],0); -ELEMENTS[42836] = Fluid3D([14427,14553,13940,14834],0); -ELEMENTS[42837] = Fluid3D([12575,11760,11657,11801],0); -ELEMENTS[42838] = Fluid3D([5621,5009,5099,5508],0); -ELEMENTS[42839] = Fluid3D([12528,12818,13503,12153],0); -ELEMENTS[42840] = Fluid3D([10174,10794,11050,10435],0); -ELEMENTS[42841] = Fluid3D([15840,15976,15899,15308],0); -ELEMENTS[42842] = Fluid3D([15840,15976,15308,15802],0); -ELEMENTS[42843] = Fluid3D([3925,4061,3555,4053],0); -ELEMENTS[42844] = Fluid3D([3555,3925,4053,4463],0); -ELEMENTS[42845] = Fluid3D([3925,4061,4053,4260],0); -ELEMENTS[42846] = Fluid3D([4053,3925,4260,4463],0); -ELEMENTS[42847] = Fluid3D([4061,4053,4260,4508],0); -ELEMENTS[42848] = Fluid3D([4053,4260,4508,4463],0); -ELEMENTS[42849] = Fluid3D([4260,4508,4463,4409],0); -ELEMENTS[42850] = Fluid3D([4260,4508,4409,4061],0); -ELEMENTS[42851] = Fluid3D([4409,4260,4061,3925],0); -ELEMENTS[42852] = Fluid3D([3925,4260,4463,4239],0); -ELEMENTS[42853] = Fluid3D([16283,16718,16358,16023],0); -ELEMENTS[42854] = Fluid3D([11049,11177,10304,11345],0); -ELEMENTS[42855] = Fluid3D([4813,5077,5004,5589],0); -ELEMENTS[42856] = Fluid3D([15646,15392,15937,16048],0); -ELEMENTS[42857] = Fluid3D([16536,16254,16711,16353],0); -ELEMENTS[42858] = Fluid3D([16254,16711,16353,16526],0); -ELEMENTS[42859] = Fluid3D([16254,16711,16526,16606],0); -ELEMENTS[42860] = Fluid3D([16353,16254,16526,15642],0); -ELEMENTS[42861] = Fluid3D([16536,16254,16353,16072],0); -ELEMENTS[42862] = Fluid3D([14748,14026,14506,14533],0); -ELEMENTS[42863] = Fluid3D([8534,7970,7626,7520],0); -ELEMENTS[42864] = Fluid3D([5809,5564,5441,4893],0); -ELEMENTS[42865] = Fluid3D([17218,17460,17453,17542],0); -ELEMENTS[42866] = Fluid3D([15318,15645,15810,15002],0); -ELEMENTS[42867] = Fluid3D([7790,7401,6955,7516],0); -ELEMENTS[42868] = Fluid3D([6955,7790,7516,7243],0); -ELEMENTS[42869] = Fluid3D([16554,16276,16116,16773],0); -ELEMENTS[42870] = Fluid3D([6339,6477,6916,6179],0); -ELEMENTS[42871] = Fluid3D([13394,14050,13186,13709],0); -ELEMENTS[42872] = Fluid3D([7681,6947,7034,6997],0); -ELEMENTS[42873] = Fluid3D([8223,9064,9090,8439],0); -ELEMENTS[42874] = Fluid3D([4234,4509,4081,4658],0); -ELEMENTS[42875] = Fluid3D([6540,6194,5802,6347],0); -ELEMENTS[42876] = Fluid3D([6194,5802,6347,6046],0); -ELEMENTS[42877] = Fluid3D([6347,6194,6046,6442],0); -ELEMENTS[42878] = Fluid3D([6540,6194,6347,7213],0); -ELEMENTS[42879] = Fluid3D([8141,8258,9005,8726],0); -ELEMENTS[42880] = Fluid3D([9005,8141,8726,9233],0); -ELEMENTS[42881] = Fluid3D([8726,9005,9233,9457],0); -ELEMENTS[42882] = Fluid3D([8141,8258,8726,8390],0); -ELEMENTS[42883] = Fluid3D([18513,18407,18561,18411],0); -ELEMENTS[42884] = Fluid3D([11948,12043,12826,12253],0); -ELEMENTS[42885] = Fluid3D([11948,12043,12253,10874],0); -ELEMENTS[42886] = Fluid3D([12043,12826,12253,12754],0); -ELEMENTS[42887] = Fluid3D([11244,11136,11558,10273],0); -ELEMENTS[42888] = Fluid3D([10424,10307,9495,10471],0); -ELEMENTS[42889] = Fluid3D([10252,9428,9677,9054],0); -ELEMENTS[42890] = Fluid3D([16436,16270,16094,16709],0); -ELEMENTS[42891] = Fluid3D([13539,12883,12931,12423],0); -ELEMENTS[42892] = Fluid3D([9780,9652,8845,9377],0); -ELEMENTS[42893] = Fluid3D([14430,13647,13915,14487],0); -ELEMENTS[42894] = Fluid3D([16069,15622,16013,16240],0); -ELEMENTS[42895] = Fluid3D([16069,15622,16240,16465],0); -ELEMENTS[42896] = Fluid3D([16240,16069,16465,16619],0); -ELEMENTS[42897] = Fluid3D([16013,16069,16240,16619],0); -ELEMENTS[42898] = Fluid3D([3386,3236,3517,3191],0); -ELEMENTS[42899] = Fluid3D([5328,5908,5417,5448],0); -ELEMENTS[42900] = Fluid3D([16635,16873,17103,16691],0); -ELEMENTS[42901] = Fluid3D([11379,11645,10586,11543],0); -ELEMENTS[42902] = Fluid3D([10586,11379,11543,10520],0); -ELEMENTS[42903] = Fluid3D([11379,11645,11543,12159],0); -ELEMENTS[42904] = Fluid3D([11543,11379,12159,11339],0); -ELEMENTS[42905] = Fluid3D([12159,11543,11339,11716],0); -ELEMENTS[42906] = Fluid3D([11543,11379,11339,10520],0); -ELEMENTS[42907] = Fluid3D([12159,11543,11716,11594],0); -ELEMENTS[42908] = Fluid3D([12159,11543,11594,12212],0); -ELEMENTS[42909] = Fluid3D([11543,11594,12212,11300],0); -ELEMENTS[42910] = Fluid3D([13483,14155,14128,13038],0); -ELEMENTS[42911] = Fluid3D([15798,14966,15252,15371],0); -ELEMENTS[42912] = Fluid3D([6018,6904,6341,6364],0); -ELEMENTS[42913] = Fluid3D([13067,14045,13710,13330],0); -ELEMENTS[42914] = Fluid3D([4928,4626,4367,4632],0); -ELEMENTS[42915] = Fluid3D([16669,16157,16655,16580],0); -ELEMENTS[42916] = Fluid3D([8547,7962,7924,7608],0); -ELEMENTS[42917] = Fluid3D([7304,6698,6456,7117],0); -ELEMENTS[42918] = Fluid3D([2224,2350,2193,2072],0); -ELEMENTS[42919] = Fluid3D([15436,15664,15378,14891],0); -ELEMENTS[42920] = Fluid3D([7026,7270,6407,6433],0); -ELEMENTS[42921] = Fluid3D([6407,7026,6433,5814],0); -ELEMENTS[42922] = Fluid3D([11184,11228,12111,11821],0); -ELEMENTS[42923] = Fluid3D([11314,10803,11632,11995],0); -ELEMENTS[42924] = Fluid3D([9462,9009,10098,9238],0); -ELEMENTS[42925] = Fluid3D([13607,14396,14198,14550],0); -ELEMENTS[42926] = Fluid3D([14493,14152,13765,14389],0); -ELEMENTS[42927] = Fluid3D([5612,6167,5748,6330],0); -ELEMENTS[42928] = Fluid3D([7336,7259,6642,6814],0); -ELEMENTS[42929] = Fluid3D([4621,4120,4434,4215],0); -ELEMENTS[42930] = Fluid3D([15911,15960,16164,16464],0); -ELEMENTS[42931] = Fluid3D([4314,3819,4005,3883],0); -ELEMENTS[42932] = Fluid3D([16644,16325,16121,16516],0); -ELEMENTS[42933] = Fluid3D([5513,5237,5276,4832],0); -ELEMENTS[42934] = Fluid3D([17887,17973,17866,18086],0); -ELEMENTS[42935] = Fluid3D([17887,17973,18086,18168],0); -ELEMENTS[42936] = Fluid3D([17887,17973,18168,18070],0); -ELEMENTS[42937] = Fluid3D([18086,17887,18168,18063],0); -ELEMENTS[42938] = Fluid3D([4911,5306,5395,4756],0); -ELEMENTS[42939] = Fluid3D([12622,11982,11560,11551],0); -ELEMENTS[42940] = Fluid3D([13871,13407,12883,12837],0); -ELEMENTS[42941] = Fluid3D([14371,13624,13660,13526],0); -ELEMENTS[42942] = Fluid3D([2086,2178,2087,1975],0); -ELEMENTS[42943] = Fluid3D([17602,17303,17732,17622],0); -ELEMENTS[42944] = Fluid3D([11040,10066,11022,10208],0); -ELEMENTS[42945] = Fluid3D([15146,15738,15797,15625],0); -ELEMENTS[42946] = Fluid3D([4086,4037,4566,4278],0); -ELEMENTS[42947] = Fluid3D([4566,4086,4278,4527],0); -ELEMENTS[42948] = Fluid3D([4278,4566,4527,4896],0); -ELEMENTS[42949] = Fluid3D([4527,4278,4896,4775],0); -ELEMENTS[42950] = Fluid3D([4086,4278,4527,3934],0); -ELEMENTS[42951] = Fluid3D([4278,4527,3934,4334],0); -ELEMENTS[42952] = Fluid3D([3934,4278,4334,4241],0); -ELEMENTS[42953] = Fluid3D([4086,4037,4278,3934],0); -ELEMENTS[42954] = Fluid3D([4278,4527,4334,4775],0); -ELEMENTS[42955] = Fluid3D([17597,17612,17774,17390],0); -ELEMENTS[42956] = Fluid3D([14226,13944,14721,14685],0); -ELEMENTS[42957] = Fluid3D([11284,11952,12268,12273],0); -ELEMENTS[42958] = Fluid3D([6292,6052,5576,6131],0); -ELEMENTS[42959] = Fluid3D([2471,2313,2601,2378],0); -ELEMENTS[42960] = Fluid3D([16580,16826,16655,17097],0); -ELEMENTS[42961] = Fluid3D([12665,13142,12231,12167],0); -ELEMENTS[42962] = Fluid3D([16303,15855,15957,15629],0); -ELEMENTS[42963] = Fluid3D([13337,14147,14019,13879],0); -ELEMENTS[42964] = Fluid3D([4029,3871,4092,3656],0); -ELEMENTS[42965] = Fluid3D([4029,3871,3656,3453],0); -ELEMENTS[42966] = Fluid3D([4029,3871,3453,3843],0); -ELEMENTS[42967] = Fluid3D([7934,7198,7588,7225],0); -ELEMENTS[42968] = Fluid3D([10248,10834,11332,11162],0); -ELEMENTS[42969] = Fluid3D([10170,9546,9963,10551],0); -ELEMENTS[42970] = Fluid3D([10170,9546,10551,10089],0); -ELEMENTS[42971] = Fluid3D([9546,9963,10551,9616],0); -ELEMENTS[42972] = Fluid3D([9546,9963,9616,9102],0); -ELEMENTS[42973] = Fluid3D([10551,9546,9616,10466],0); -ELEMENTS[42974] = Fluid3D([9963,10170,10551,11013],0); -ELEMENTS[42975] = Fluid3D([9963,10170,11013,9591],0); -ELEMENTS[42976] = Fluid3D([10170,10551,11013,11229],0); -ELEMENTS[42977] = Fluid3D([10551,9963,11013,10757],0); -ELEMENTS[42978] = Fluid3D([10309,10911,11133,10326],0); -ELEMENTS[42979] = Fluid3D([4634,4934,4383,4427],0); -ELEMENTS[42980] = Fluid3D([13737,13815,14481,13842],0); -ELEMENTS[42981] = Fluid3D([17704,17635,17317,17607],0); -ELEMENTS[42982] = Fluid3D([10305,10724,9762,9487],0); -ELEMENTS[42983] = Fluid3D([18434,18328,18235,18472],0); -ELEMENTS[42984] = Fluid3D([9853,9207,9798,9108],0); -ELEMENTS[42985] = Fluid3D([14169,14313,13633,14491],0); -ELEMENTS[42986] = Fluid3D([8956,8659,9080,9884],0); -ELEMENTS[42987] = Fluid3D([3577,3211,3643,3336],0); -ELEMENTS[42988] = Fluid3D([15627,16151,15492,15806],0); -ELEMENTS[42989] = Fluid3D([12426,13021,11966,13126],0); -ELEMENTS[42990] = Fluid3D([5421,5777,5663,6346],0); -ELEMENTS[42991] = Fluid3D([13500,12893,13094,13204],0); -ELEMENTS[42992] = Fluid3D([6320,6170,6183,5473],0); -ELEMENTS[42993] = Fluid3D([5524,5805,5993,5118],0); -ELEMENTS[42994] = Fluid3D([5355,5388,5681,5784],0); -ELEMENTS[42995] = Fluid3D([16341,16677,16810,16965],0); -ELEMENTS[42996] = Fluid3D([6230,6692,6172,5845],0); -ELEMENTS[42997] = Fluid3D([16171,16601,16327,15737],0); -ELEMENTS[42998] = Fluid3D([15868,15791,15248,15580],0); -ELEMENTS[42999] = Fluid3D([14066,13257,13063,13634],0); -ELEMENTS[43000] = Fluid3D([12880,12517,13244,12218],0); -ELEMENTS[43001] = Fluid3D([18135,17872,17826,17935],0); -ELEMENTS[43002] = Fluid3D([5360,5349,4957,5885],0); -ELEMENTS[43003] = Fluid3D([5360,5349,5885,5926],0); -ELEMENTS[43004] = Fluid3D([16640,16444,16763,17167],0); -ELEMENTS[43005] = Fluid3D([10061,9087,9614,9157],0); -ELEMENTS[43006] = Fluid3D([8795,9710,8848,8840],0); -ELEMENTS[43007] = Fluid3D([10082,11068,10719,9917],0); -ELEMENTS[43008] = Fluid3D([15064,14531,14830,15261],0); -ELEMENTS[43009] = Fluid3D([14531,14830,15261,14414],0); -ELEMENTS[43010] = Fluid3D([13313,12465,12730,12384],0); -ELEMENTS[43011] = Fluid3D([10068,9247,10149,9637],0); -ELEMENTS[43012] = Fluid3D([15804,15225,15495,15811],0); -ELEMENTS[43013] = Fluid3D([15225,15495,15811,15752],0); -ELEMENTS[43014] = Fluid3D([15804,15225,15811,16039],0); -ELEMENTS[43015] = Fluid3D([15811,15804,16039,16298],0); -ELEMENTS[43016] = Fluid3D([16039,15811,16298,16352],0); -ELEMENTS[43017] = Fluid3D([15811,16298,16352,16049],0); -ELEMENTS[43018] = Fluid3D([16039,15811,16352,15752],0); -ELEMENTS[43019] = Fluid3D([16039,15811,15752,15406],0); -ELEMENTS[43020] = Fluid3D([15811,16352,15752,16049],0); -ELEMENTS[43021] = Fluid3D([16298,16352,16049,16621],0); -ELEMENTS[43022] = Fluid3D([16298,16039,16352,16494],0); -ELEMENTS[43023] = Fluid3D([15811,15752,15406,15225],0); -ELEMENTS[43024] = Fluid3D([16039,15811,15406,15225],0); -ELEMENTS[43025] = Fluid3D([15811,16298,16049,15804],0); -ELEMENTS[43026] = Fluid3D([16049,16298,16621,16261],0); -ELEMENTS[43027] = Fluid3D([16298,16039,16494,15804],0); -ELEMENTS[43028] = Fluid3D([11823,12226,12704,13085],0); -ELEMENTS[43029] = Fluid3D([15385,16032,16000,15909],0); -ELEMENTS[43030] = Fluid3D([16000,15385,15909,15399],0); -ELEMENTS[43031] = Fluid3D([12879,13046,13145,12099],0); -ELEMENTS[43032] = Fluid3D([15094,15090,15609,15587],0); -ELEMENTS[43033] = Fluid3D([12644,12961,13619,13196],0); -ELEMENTS[43034] = Fluid3D([3015,3292,3370,3207],0); -ELEMENTS[43035] = Fluid3D([3292,3370,3207,3306],0); -ELEMENTS[43036] = Fluid3D([3370,3015,3207,3061],0); -ELEMENTS[43037] = Fluid3D([3207,3370,3061,3620],0); -ELEMENTS[43038] = Fluid3D([9681,9402,8829,8890],0); -ELEMENTS[43039] = Fluid3D([9214,8588,8501,8138],0); -ELEMENTS[43040] = Fluid3D([14047,14137,14933,14525],0); -ELEMENTS[43041] = Fluid3D([14933,14047,14525,14009],0); -ELEMENTS[43042] = Fluid3D([14047,14525,14009,13812],0); -ELEMENTS[43043] = Fluid3D([14047,14525,13812,14137],0); -ELEMENTS[43044] = Fluid3D([14525,13812,14137,14715],0); -ELEMENTS[43045] = Fluid3D([17859,18096,18152,18070],0); -ELEMENTS[43046] = Fluid3D([7452,6653,6807,6790],0); -ELEMENTS[43047] = Fluid3D([8536,8823,8998,9788],0); -ELEMENTS[43048] = Fluid3D([16998,16868,16727,16512],0); -ELEMENTS[43049] = Fluid3D([10745,11455,11579,10766],0); -ELEMENTS[43050] = Fluid3D([11732,10679,11207,10782],0); -ELEMENTS[43051] = Fluid3D([11207,11732,10782,11955],0); -ELEMENTS[43052] = Fluid3D([10679,11207,10782,10168],0); -ELEMENTS[43053] = Fluid3D([11207,10782,10168,10186],0); -ELEMENTS[43054] = Fluid3D([10782,10679,10168,9860],0); -ELEMENTS[43055] = Fluid3D([10679,11207,10168,11077],0); -ELEMENTS[43056] = Fluid3D([10168,10782,9860,10092],0); -ELEMENTS[43057] = Fluid3D([10782,9860,10092,10370],0); -ELEMENTS[43058] = Fluid3D([10168,10782,10092,10186],0); -ELEMENTS[43059] = Fluid3D([10092,10168,10186,9351],0); -ELEMENTS[43060] = Fluid3D([10186,10092,9351,9659],0); -ELEMENTS[43061] = Fluid3D([10092,10168,9351,9860],0); -ELEMENTS[43062] = Fluid3D([10168,10186,9351,9818],0); -ELEMENTS[43063] = Fluid3D([10186,9351,9818,9573],0); -ELEMENTS[43064] = Fluid3D([9351,10168,9818,8743],0); -ELEMENTS[43065] = Fluid3D([10186,9351,9573,9659],0); -ELEMENTS[43066] = Fluid3D([10168,10186,9818,10860],0); -ELEMENTS[43067] = Fluid3D([10186,9818,10860,10447],0); -ELEMENTS[43068] = Fluid3D([9818,10860,10447,10358],0); -ELEMENTS[43069] = Fluid3D([10186,9818,10447,9588],0); -ELEMENTS[43070] = Fluid3D([10860,10186,10447,10905],0); -ELEMENTS[43071] = Fluid3D([10860,10186,10905,11207],0); -ELEMENTS[43072] = Fluid3D([10905,10860,11207,12156],0); -ELEMENTS[43073] = Fluid3D([10447,10860,10905,11521],0); -ELEMENTS[43074] = Fluid3D([10860,10905,11521,12156],0); -ELEMENTS[43075] = Fluid3D([10186,10905,11207,10782],0); -ELEMENTS[43076] = Fluid3D([10186,10447,10905,11277],0); -ELEMENTS[43077] = Fluid3D([10447,10860,11521,11280],0); -ELEMENTS[43078] = Fluid3D([9818,10168,10860,9919],0); -ELEMENTS[43079] = Fluid3D([10447,10186,9588,10488],0); -ELEMENTS[43080] = Fluid3D([10860,10186,11207,10168],0); -ELEMENTS[43081] = Fluid3D([11207,10860,10168,10801],0); -ELEMENTS[43082] = Fluid3D([11207,10860,10801,11240],0); -ELEMENTS[43083] = Fluid3D([10168,11207,10801,11077],0); -ELEMENTS[43084] = Fluid3D([10860,10168,10801,9919],0); -ELEMENTS[43085] = Fluid3D([11207,10801,11077,11240],0); -ELEMENTS[43086] = Fluid3D([10801,11077,11240,9919],0); -ELEMENTS[43087] = Fluid3D([10801,11077,9919,10168],0); -ELEMENTS[43088] = Fluid3D([16852,16347,16436,16099],0); -ELEMENTS[43089] = Fluid3D([9079,8505,8977,8208],0); -ELEMENTS[43090] = Fluid3D([11554,10686,10636,11038],0); -ELEMENTS[43091] = Fluid3D([13506,13656,12817,12965],0); -ELEMENTS[43092] = Fluid3D([14313,14952,14832,14877],0); -ELEMENTS[43093] = Fluid3D([9354,9015,9070,8416],0); -ELEMENTS[43094] = Fluid3D([18399,18432,18535,18518],0); -ELEMENTS[43095] = Fluid3D([14103,14616,13975,13720],0); -ELEMENTS[43096] = Fluid3D([15079,14894,15009,15256],0); -ELEMENTS[43097] = Fluid3D([6251,5769,6306,6711],0); -ELEMENTS[43098] = Fluid3D([3423,3576,3779,3196],0); -ELEMENTS[43099] = Fluid3D([12918,13281,13870,13036],0); -ELEMENTS[43100] = Fluid3D([7416,6728,7170,6528],0); -ELEMENTS[43101] = Fluid3D([14722,14398,15054,15010],0); -ELEMENTS[43102] = Fluid3D([6919,7110,6779,7806],0); -ELEMENTS[43103] = Fluid3D([15107,15383,15322,15860],0); -ELEMENTS[43104] = Fluid3D([10703,11016,11108,11998],0); -ELEMENTS[43105] = Fluid3D([6146,6644,6926,6028],0); -ELEMENTS[43106] = Fluid3D([18117,17925,18131,18306],0); -ELEMENTS[43107] = Fluid3D([11005,11255,11731,12221],0); -ELEMENTS[43108] = Fluid3D([13864,14489,13609,13743],0); -ELEMENTS[43109] = Fluid3D([7899,8153,8152,8912],0); -ELEMENTS[43110] = Fluid3D([11373,11976,12038,11087],0); -ELEMENTS[43111] = Fluid3D([12394,12284,13053,13052],0); -ELEMENTS[43112] = Fluid3D([11729,11921,10901,11030],0); -ELEMENTS[43113] = Fluid3D([11861,11902,12613,11768],0); -ELEMENTS[43114] = Fluid3D([17543,17232,17224,17045],0); -ELEMENTS[43115] = Fluid3D([4659,5106,4570,4742],0); -ELEMENTS[43116] = Fluid3D([6899,6320,6183,6997],0); -ELEMENTS[43117] = Fluid3D([11313,12215,12366,11292],0); -ELEMENTS[43118] = Fluid3D([11313,12215,11292,10384],0); -ELEMENTS[43119] = Fluid3D([12106,12121,11201,12025],0); -ELEMENTS[43120] = Fluid3D([14998,14929,14440,13702],0); -ELEMENTS[43121] = Fluid3D([10005,10160,11034,10575],0); -ELEMENTS[43122] = Fluid3D([10005,10160,10575,10369],0); -ELEMENTS[43123] = Fluid3D([10160,11034,10575,10800],0); -ELEMENTS[43124] = Fluid3D([12668,12497,12835,13377],0); -ELEMENTS[43125] = Fluid3D([12668,12497,13377,13301],0); -ELEMENTS[43126] = Fluid3D([12497,12835,13377,13238],0); -ELEMENTS[43127] = Fluid3D([6017,6198,5627,6103],0); -ELEMENTS[43128] = Fluid3D([13965,13515,14030,14470],0); -ELEMENTS[43129] = Fluid3D([6014,5582,6174,6362],0); -ELEMENTS[43130] = Fluid3D([16971,17017,16848,17350],0); -ELEMENTS[43131] = Fluid3D([5775,6151,6564,5930],0); -ELEMENTS[43132] = Fluid3D([5851,5743,5402,5002],0); -ELEMENTS[43133] = Fluid3D([8706,9482,8736,9412],0); -ELEMENTS[43134] = Fluid3D([17715,17572,17558,17953],0); -ELEMENTS[43135] = Fluid3D([18487,18537,18574,18588],0); -ELEMENTS[43136] = Fluid3D([18537,18574,18588,18626],0); -ELEMENTS[43137] = Fluid3D([18487,18537,18588,18444],0); -ELEMENTS[43138] = Fluid3D([13675,14092,13418,14229],0); -ELEMENTS[43139] = Fluid3D([7258,8021,7217,7154],0); -ELEMENTS[43140] = Fluid3D([17490,17496,17147,17513],0); -ELEMENTS[43141] = Fluid3D([17147,17490,17513,17384],0); -ELEMENTS[43142] = Fluid3D([17513,17147,17384,17198],0); -ELEMENTS[43143] = Fluid3D([17490,17513,17384,17765],0); -ELEMENTS[43144] = Fluid3D([17490,17513,17765,17496],0); -ELEMENTS[43145] = Fluid3D([17765,17490,17496,17632],0); -ELEMENTS[43146] = Fluid3D([17765,17490,17632,17883],0); -ELEMENTS[43147] = Fluid3D([17147,17490,17384,17374],0); -ELEMENTS[43148] = Fluid3D([17384,17513,17198,17681],0); -ELEMENTS[43149] = Fluid3D([17384,17513,17681,17765],0); -ELEMENTS[43150] = Fluid3D([17513,17198,17681,17496],0); -ELEMENTS[43151] = Fluid3D([17513,17681,17765,17496],0); -ELEMENTS[43152] = Fluid3D([8375,8746,8345,9396],0); -ELEMENTS[43153] = Fluid3D([13631,12711,13291,13390],0); -ELEMENTS[43154] = Fluid3D([9488,9790,10552,9956],0); -ELEMENTS[43155] = Fluid3D([16038,16459,16095,15538],0); -ELEMENTS[43156] = Fluid3D([6008,5728,6263,6299],0); -ELEMENTS[43157] = Fluid3D([5804,6261,5830,5759],0); -ELEMENTS[43158] = Fluid3D([7499,6720,7494,6916],0); -ELEMENTS[43159] = Fluid3D([15099,15254,15507,14462],0); -ELEMENTS[43160] = Fluid3D([10985,11182,10264,11775],0); -ELEMENTS[43161] = Fluid3D([9464,9358,8643,9852],0); -ELEMENTS[43162] = Fluid3D([12312,11620,11393,11442],0); -ELEMENTS[43163] = Fluid3D([12637,13063,12144,13257],0); -ELEMENTS[43164] = Fluid3D([9212,8530,8359,8375],0); -ELEMENTS[43165] = Fluid3D([16685,16735,16383,16814],0); -ELEMENTS[43166] = Fluid3D([15439,14946,14784,14785],0); -ELEMENTS[43167] = Fluid3D([8731,8680,8449,9138],0); -ELEMENTS[43168] = Fluid3D([8449,8731,9138,8081],0); -ELEMENTS[43169] = Fluid3D([16188,15931,16355,15749],0); -ELEMENTS[43170] = Fluid3D([14499,14748,14506,15390],0); -ELEMENTS[43171] = Fluid3D([3540,3550,3787,4084],0); -ELEMENTS[43172] = Fluid3D([4550,4816,5038,4405],0); -ELEMENTS[43173] = Fluid3D([16755,16225,16558,16581],0); -ELEMENTS[43174] = Fluid3D([11767,12128,11111,11918],0); -ELEMENTS[43175] = Fluid3D([18475,18348,18344,18448],0); -ELEMENTS[43176] = Fluid3D([15350,14535,14942,14821],0); -ELEMENTS[43177] = Fluid3D([13885,14247,14155,13449],0); -ELEMENTS[43178] = Fluid3D([3880,3740,4010,4231],0); -ELEMENTS[43179] = Fluid3D([10659,11639,11021,11102],0); -ELEMENTS[43180] = Fluid3D([3533,3942,3878,3429],0); -ELEMENTS[43181] = Fluid3D([3533,3942,3429,3375],0); -ELEMENTS[43182] = Fluid3D([7769,7978,7808,7169],0); -ELEMENTS[43183] = Fluid3D([7808,7769,7169,6919],0); -ELEMENTS[43184] = Fluid3D([7769,7169,6919,6980],0); -ELEMENTS[43185] = Fluid3D([7769,7169,6980,6841],0); -ELEMENTS[43186] = Fluid3D([18038,17884,17787,17722],0); -ELEMENTS[43187] = Fluid3D([12635,12310,11796,11966],0); -ELEMENTS[43188] = Fluid3D([7749,8271,7485,8044],0); -ELEMENTS[43189] = Fluid3D([16148,15701,16025,16544],0); -ELEMENTS[43190] = Fluid3D([8843,8998,9682,9114],0); -ELEMENTS[43191] = Fluid3D([8843,8998,9114,8545],0); -ELEMENTS[43192] = Fluid3D([9114,8843,8545,9135],0); -ELEMENTS[43193] = Fluid3D([9114,8843,9135,9682],0); -ELEMENTS[43194] = Fluid3D([2365,2188,2380,2401],0); -ELEMENTS[43195] = Fluid3D([8296,9115,8966,9119],0); -ELEMENTS[43196] = Fluid3D([17020,17247,16985,16807],0); -ELEMENTS[43197] = Fluid3D([10922,10374,11222,10225],0); -ELEMENTS[43198] = Fluid3D([8069,7907,8198,7316],0); -ELEMENTS[43199] = Fluid3D([13814,14125,13282,14350],0); -ELEMENTS[43200] = Fluid3D([13582,13799,14337,13863],0); -ELEMENTS[43201] = Fluid3D([9009,8187,9070,8333],0); -ELEMENTS[43202] = Fluid3D([4032,4136,3955,3505],0); -ELEMENTS[43203] = Fluid3D([15331,15042,14885,15543],0); -ELEMENTS[43204] = Fluid3D([6081,6082,5615,6368],0); -ELEMENTS[43205] = Fluid3D([14961,14904,15458,14910],0); -ELEMENTS[43206] = Fluid3D([13655,13205,13364,14140],0); -ELEMENTS[43207] = Fluid3D([8444,8772,8968,8063],0); -ELEMENTS[43208] = Fluid3D([8444,8772,8063,7554],0); -ELEMENTS[43209] = Fluid3D([8063,8444,7554,7828],0); -ELEMENTS[43210] = Fluid3D([8772,8968,8063,7953],0); -ELEMENTS[43211] = Fluid3D([8063,8772,7953,7554],0); -ELEMENTS[43212] = Fluid3D([7953,8063,7554,8021],0); -ELEMENTS[43213] = Fluid3D([7953,8063,8021,8968],0); -ELEMENTS[43214] = Fluid3D([8063,7554,8021,7828],0); -ELEMENTS[43215] = Fluid3D([8063,8021,8968,7828],0); -ELEMENTS[43216] = Fluid3D([4379,4004,4088,4561],0); -ELEMENTS[43217] = Fluid3D([4649,5052,4821,4392],0); -ELEMENTS[43218] = Fluid3D([11164,12088,11978,12554],0); -ELEMENTS[43219] = Fluid3D([16171,16255,16601,15737],0); -ELEMENTS[43220] = Fluid3D([14864,15132,14229,15059],0); -ELEMENTS[43221] = Fluid3D([8657,7936,8518,9230],0); -ELEMENTS[43222] = Fluid3D([2463,2346,2383,2219],0); -ELEMENTS[43223] = Fluid3D([15405,15011,15690,15632],0); -ELEMENTS[43224] = Fluid3D([15011,15690,15632,15343],0); -ELEMENTS[43225] = Fluid3D([11579,11742,11352,12436],0); -ELEMENTS[43226] = Fluid3D([13185,12292,12822,12608],0); -ELEMENTS[43227] = Fluid3D([12822,13185,12608,13451],0); -ELEMENTS[43228] = Fluid3D([13185,12292,12608,12209],0); -ELEMENTS[43229] = Fluid3D([12292,12822,12608,12056],0); -ELEMENTS[43230] = Fluid3D([12822,12608,12056,12992],0); -ELEMENTS[43231] = Fluid3D([12822,12608,12992,13451],0); -ELEMENTS[43232] = Fluid3D([12608,12056,12992,12572],0); -ELEMENTS[43233] = Fluid3D([12056,12822,12992,12569],0); -ELEMENTS[43234] = Fluid3D([12992,12056,12569,12572],0); -ELEMENTS[43235] = Fluid3D([12608,12992,13451,12572],0); -ELEMENTS[43236] = Fluid3D([12992,13451,12572,12569],0); -ELEMENTS[43237] = Fluid3D([17759,17721,17602,17974],0); -ELEMENTS[43238] = Fluid3D([4937,5065,4477,4657],0); -ELEMENTS[43239] = Fluid3D([12565,12911,13106,13620],0); -ELEMENTS[43240] = Fluid3D([13888,13250,13315,14401],0); -ELEMENTS[43241] = Fluid3D([10486,9977,9411,9981],0); -ELEMENTS[43242] = Fluid3D([14068,13270,13988,14111],0); -ELEMENTS[43243] = Fluid3D([11944,12017,12688,12787],0); -ELEMENTS[43244] = Fluid3D([12189,12252,12959,12825],0); -ELEMENTS[43245] = Fluid3D([12959,12189,12825,13278],0); -ELEMENTS[43246] = Fluid3D([3227,2965,3310,3109],0); -ELEMENTS[43247] = Fluid3D([3227,2965,3109,2784],0); -ELEMENTS[43248] = Fluid3D([14355,14316,15062,14764],0); -ELEMENTS[43249] = Fluid3D([4587,5099,4794,5195],0); -ELEMENTS[43250] = Fluid3D([5656,5564,5809,5174],0); -ELEMENTS[43251] = Fluid3D([5564,5809,5174,4893],0); -ELEMENTS[43252] = Fluid3D([5656,5564,5174,5220],0); -ELEMENTS[43253] = Fluid3D([15768,15061,15175,15918],0); -ELEMENTS[43254] = Fluid3D([18472,18429,18333,18252],0); -ELEMENTS[43255] = Fluid3D([1828,1783,1854,1680],0); -ELEMENTS[43256] = Fluid3D([7218,7156,7951,7498],0); -ELEMENTS[43257] = Fluid3D([9117,8878,9801,8289],0); -ELEMENTS[43258] = Fluid3D([6667,6386,6723,7461],0); -ELEMENTS[43259] = Fluid3D([12279,12398,11559,11732],0); -ELEMENTS[43260] = Fluid3D([10338,9796,10384,9664],0); -ELEMENTS[43261] = Fluid3D([10384,10338,9664,10959],0); -ELEMENTS[43262] = Fluid3D([10338,9796,9664,9885],0); -ELEMENTS[43263] = Fluid3D([10087,10993,10724,10016],0); -ELEMENTS[43264] = Fluid3D([18571,18552,18617,18622],0); -ELEMENTS[43265] = Fluid3D([18552,18617,18622,18591],0); -ELEMENTS[43266] = Fluid3D([18622,18552,18591,18557],0); -ELEMENTS[43267] = Fluid3D([18622,18552,18557,18604],0); -ELEMENTS[43268] = Fluid3D([18552,18591,18557,18506],0); -ELEMENTS[43269] = Fluid3D([18571,18552,18622,18604],0); -ELEMENTS[43270] = Fluid3D([18617,18571,18622,18654],0); -ELEMENTS[43271] = Fluid3D([11876,12007,11488,12721],0); -ELEMENTS[43272] = Fluid3D([9054,8978,9677,9853],0); -ELEMENTS[43273] = Fluid3D([14269,14188,13942,14892],0); -ELEMENTS[43274] = Fluid3D([2687,2842,2892,3129],0); -ELEMENTS[43275] = Fluid3D([15897,16095,15803,15277],0); -ELEMENTS[43276] = Fluid3D([9802,10544,10895,10964],0); -ELEMENTS[43277] = Fluid3D([12592,11630,11966,11769],0); -ELEMENTS[43278] = Fluid3D([7540,6842,6902,7732],0); -ELEMENTS[43279] = Fluid3D([6198,6777,6872,6793],0); -ELEMENTS[43280] = Fluid3D([6872,6198,6793,6657],0); -ELEMENTS[43281] = Fluid3D([6198,6777,6793,6729],0); -ELEMENTS[43282] = Fluid3D([6793,6872,6657,7519],0); -ELEMENTS[43283] = Fluid3D([6777,6872,6793,7428],0); -ELEMENTS[43284] = Fluid3D([6872,6793,7428,7519],0); -ELEMENTS[43285] = Fluid3D([6793,6777,7428,7587],0); -ELEMENTS[43286] = Fluid3D([6777,7428,7587,7561],0); -ELEMENTS[43287] = Fluid3D([7428,6793,7587,7507],0); -ELEMENTS[43288] = Fluid3D([7587,7428,7507,8453],0); -ELEMENTS[43289] = Fluid3D([14643,14483,13869,13365],0); -ELEMENTS[43290] = Fluid3D([5784,6238,5935,5681],0); -ELEMENTS[43291] = Fluid3D([16492,16593,16051,16126],0); -ELEMENTS[43292] = Fluid3D([4089,4672,4427,4516],0); -ELEMENTS[43293] = Fluid3D([11982,11105,11020,11341],0); -ELEMENTS[43294] = Fluid3D([16157,15999,15667,15786],0); -ELEMENTS[43295] = Fluid3D([12773,13642,12866,12815],0); -ELEMENTS[43296] = Fluid3D([15275,15405,15690,15838],0); -ELEMENTS[43297] = Fluid3D([2298,2451,2455,2652],0); -ELEMENTS[43298] = Fluid3D([18208,18407,18264,18269],0); -ELEMENTS[43299] = Fluid3D([18264,18208,18269,17958],0); -ELEMENTS[43300] = Fluid3D([7519,7121,7856,7932],0); -ELEMENTS[43301] = Fluid3D([12799,13187,13550,13907],0); -ELEMENTS[43302] = Fluid3D([10274,10322,10778,11284],0); -ELEMENTS[43303] = Fluid3D([14408,14811,14421,13764],0); -ELEMENTS[43304] = Fluid3D([15526,15391,14880,15362],0); -ELEMENTS[43305] = Fluid3D([12231,11175,11443,11391],0); -ELEMENTS[43306] = Fluid3D([16590,16712,16790,16331],0); -ELEMENTS[43307] = Fluid3D([16389,15985,15877,16201],0); -ELEMENTS[43308] = Fluid3D([16389,15985,16201,16749],0); -ELEMENTS[43309] = Fluid3D([15985,15877,16201,15716],0); -ELEMENTS[43310] = Fluid3D([13993,13145,13898,13858],0); -ELEMENTS[43311] = Fluid3D([14625,14341,14820,15385],0); -ELEMENTS[43312] = Fluid3D([12763,11893,11965,12478],0); -ELEMENTS[43313] = Fluid3D([15856,15831,16447,15842],0); -ELEMENTS[43314] = Fluid3D([3503,3846,3582,4000],0); -ELEMENTS[43315] = Fluid3D([11276,11616,11514,12056],0); -ELEMENTS[43316] = Fluid3D([18426,18278,18314,18415],0); -ELEMENTS[43317] = Fluid3D([15097,15197,15586,14564],0); -ELEMENTS[43318] = Fluid3D([8073,7810,7868,8591],0); -ELEMENTS[43319] = Fluid3D([6678,6790,6134,6924],0); -ELEMENTS[43320] = Fluid3D([12645,12892,12348,13268],0); -ELEMENTS[43321] = Fluid3D([12892,12348,13268,13528],0); -ELEMENTS[43322] = Fluid3D([13268,12892,13528,13554],0); -ELEMENTS[43323] = Fluid3D([12892,13528,13554,13118],0); -ELEMENTS[43324] = Fluid3D([12892,13528,13118,12711],0); -ELEMENTS[43325] = Fluid3D([13528,13268,13554,13698],0); -ELEMENTS[43326] = Fluid3D([13528,13268,13698,14029],0); -ELEMENTS[43327] = Fluid3D([13268,13698,14029,13113],0); -ELEMENTS[43328] = Fluid3D([13268,13698,13113,12761],0); -ELEMENTS[43329] = Fluid3D([14029,13268,13113,13528],0); -ELEMENTS[43330] = Fluid3D([13268,13113,13528,12348],0); -ELEMENTS[43331] = Fluid3D([13268,13113,12348,12761],0); -ELEMENTS[43332] = Fluid3D([12645,12892,13268,13554],0); -ELEMENTS[43333] = Fluid3D([10254,10941,10421,9973],0); -ELEMENTS[43334] = Fluid3D([18187,18108,18288,18339],0); -ELEMENTS[43335] = Fluid3D([13860,12981,13657,13825],0); -ELEMENTS[43336] = Fluid3D([18107,18270,18092,18037],0); -ELEMENTS[43337] = Fluid3D([10400,10982,10115,10273],0); -ELEMENTS[43338] = Fluid3D([9618,10281,9570,10916],0); -ELEMENTS[43339] = Fluid3D([15307,14614,14944,14772],0); -ELEMENTS[43340] = Fluid3D([15307,14614,14772,14980],0); -ELEMENTS[43341] = Fluid3D([14614,14944,14772,13954],0); -ELEMENTS[43342] = Fluid3D([5450,5542,5292,4940],0); -ELEMENTS[43343] = Fluid3D([5292,5450,4940,5498],0); -ELEMENTS[43344] = Fluid3D([15541,15072,14908,15421],0); -ELEMENTS[43345] = Fluid3D([14908,15541,15421,15545],0); -ELEMENTS[43346] = Fluid3D([7491,7132,6799,6349],0); -ELEMENTS[43347] = Fluid3D([7132,6799,6349,6352],0); -ELEMENTS[43348] = Fluid3D([14636,14130,14201,14362],0); -ELEMENTS[43349] = Fluid3D([14130,14201,14362,13399],0); -ELEMENTS[43350] = Fluid3D([14586,14758,14223,13682],0); -ELEMENTS[43351] = Fluid3D([3330,3247,3423,3863],0); -ELEMENTS[43352] = Fluid3D([7073,6615,6259,6868],0); -ELEMENTS[43353] = Fluid3D([14160,14587,13994,13687],0); -ELEMENTS[43354] = Fluid3D([4097,4109,3667,4296],0); -ELEMENTS[43355] = Fluid3D([15022,15168,14445,14300],0); -ELEMENTS[43356] = Fluid3D([10835,11423,11130,11843],0); -ELEMENTS[43357] = Fluid3D([3088,2744,3060,3206],0); -ELEMENTS[43358] = Fluid3D([17573,17478,17430,17138],0); -ELEMENTS[43359] = Fluid3D([13343,12609,12804,12411],0); -ELEMENTS[43360] = Fluid3D([12804,13343,12411,12694],0); -ELEMENTS[43361] = Fluid3D([13343,12411,12694,12851],0); -ELEMENTS[43362] = Fluid3D([12609,12804,12411,11708],0); -ELEMENTS[43363] = Fluid3D([13343,12609,12411,12851],0); -ELEMENTS[43364] = Fluid3D([11209,12188,11663,12063],0); -ELEMENTS[43365] = Fluid3D([13174,13610,12777,12414],0); -ELEMENTS[43366] = Fluid3D([16971,17350,17338,17017],0); -ELEMENTS[43367] = Fluid3D([10605,10901,10965,11921],0); -ELEMENTS[43368] = Fluid3D([17177,17634,17393,17352],0); -ELEMENTS[43369] = Fluid3D([2899,2858,3108,2546],0); -ELEMENTS[43370] = Fluid3D([14553,13937,14441,14768],0); -ELEMENTS[43371] = Fluid3D([15182,15744,15913,15603],0); -ELEMENTS[43372] = Fluid3D([13938,14009,13468,13284],0); -ELEMENTS[43373] = Fluid3D([4034,3855,3916,3462],0); -ELEMENTS[43374] = Fluid3D([9832,10105,10851,10825],0); -ELEMENTS[43375] = Fluid3D([13300,12369,12528,12667],0); -ELEMENTS[43376] = Fluid3D([2828,3182,3176,3036],0); -ELEMENTS[43377] = Fluid3D([13915,13647,13200,14487],0); -ELEMENTS[43378] = Fluid3D([9391,9676,8489,8693],0); -ELEMENTS[43379] = Fluid3D([10911,11259,11133,11803],0); -ELEMENTS[43380] = Fluid3D([7897,8058,8495,8616],0); -ELEMENTS[43381] = Fluid3D([11235,11862,10990,10450],0); -ELEMENTS[43382] = Fluid3D([11277,12145,12178,11987],0); -ELEMENTS[43383] = Fluid3D([18108,18036,18288,18177],0); -ELEMENTS[43384] = Fluid3D([18288,18108,18177,18339],0); -ELEMENTS[43385] = Fluid3D([17251,17083,16926,16805],0); -ELEMENTS[43386] = Fluid3D([13667,13088,13842,12754],0); -ELEMENTS[43387] = Fluid3D([6713,6855,6190,7243],0); -ELEMENTS[43388] = Fluid3D([8550,8306,7621,8799],0); -ELEMENTS[43389] = Fluid3D([14246,13528,13631,13390],0); -ELEMENTS[43390] = Fluid3D([16723,16247,16407,16552],0); -ELEMENTS[43391] = Fluid3D([9408,9704,9330,10612],0); -ELEMENTS[43392] = Fluid3D([5525,4884,5261,5605],0); -ELEMENTS[43393] = Fluid3D([14278,14950,15082,14679],0); -ELEMENTS[43394] = Fluid3D([14278,14950,14679,14555],0); -ELEMENTS[43395] = Fluid3D([14679,14278,14555,14210],0); -ELEMENTS[43396] = Fluid3D([14679,14278,14210,15082],0); -ELEMENTS[43397] = Fluid3D([14555,14679,14210,14111],0); -ELEMENTS[43398] = Fluid3D([14950,14679,14555,15323],0); -ELEMENTS[43399] = Fluid3D([14679,14555,15323,15214],0); -ELEMENTS[43400] = Fluid3D([14679,14555,15214,14648],0); -ELEMENTS[43401] = Fluid3D([14679,14555,14648,14111],0); -ELEMENTS[43402] = Fluid3D([14278,14555,14210,13770],0); -ELEMENTS[43403] = Fluid3D([14210,14278,13770,13434],0); -ELEMENTS[43404] = Fluid3D([14210,14278,13434,14171],0); -ELEMENTS[43405] = Fluid3D([14210,14278,14171,15082],0); -ELEMENTS[43406] = Fluid3D([8906,9005,9534,10139],0); -ELEMENTS[43407] = Fluid3D([7034,7941,7621,7189],0); -ELEMENTS[43408] = Fluid3D([15745,16222,15793,15966],0); -ELEMENTS[43409] = Fluid3D([8258,8230,7778,9090],0); -ELEMENTS[43410] = Fluid3D([13394,12772,13358,13986],0); -ELEMENTS[43411] = Fluid3D([6543,6037,6009,6892],0); -ELEMENTS[43412] = Fluid3D([9219,8658,8633,8331],0); -ELEMENTS[43413] = Fluid3D([10378,10612,10630,9408],0); -ELEMENTS[43414] = Fluid3D([17569,17827,17419,17625],0); -ELEMENTS[43415] = Fluid3D([17827,17419,17625,17636],0); -ELEMENTS[43416] = Fluid3D([17625,17827,17636,17795],0); -ELEMENTS[43417] = Fluid3D([17419,17625,17636,17319],0); -ELEMENTS[43418] = Fluid3D([17419,17625,17319,17164],0); -ELEMENTS[43419] = Fluid3D([17625,17636,17319,17565],0); -ELEMENTS[43420] = Fluid3D([17569,17827,17625,17728],0); -ELEMENTS[43421] = Fluid3D([17419,17569,17625,17164],0); -ELEMENTS[43422] = Fluid3D([17827,17625,17728,18018],0); -ELEMENTS[43423] = Fluid3D([17827,17625,18018,17795],0); -ELEMENTS[43424] = Fluid3D([17636,17419,17319,17258],0); -ELEMENTS[43425] = Fluid3D([17636,17625,17795,17565],0); -ELEMENTS[43426] = Fluid3D([17319,17636,17258,17565],0); -ELEMENTS[43427] = Fluid3D([6944,6809,7297,6568],0); -ELEMENTS[43428] = Fluid3D([7297,6944,6568,7154],0); -ELEMENTS[43429] = Fluid3D([6944,6809,6568,5953],0); -ELEMENTS[43430] = Fluid3D([9279,10068,10154,9875],0); -ELEMENTS[43431] = Fluid3D([10154,9279,9875,9082],0); -ELEMENTS[43432] = Fluid3D([9382,9334,10072,8923],0); -ELEMENTS[43433] = Fluid3D([16386,15760,15876,16235],0); -ELEMENTS[43434] = Fluid3D([12740,12182,12911,13022],0); -ELEMENTS[43435] = Fluid3D([6047,6618,5875,5806],0); -ELEMENTS[43436] = Fluid3D([2743,2747,2771,3144],0); -ELEMENTS[43437] = Fluid3D([15854,16355,15931,15749],0); -ELEMENTS[43438] = Fluid3D([6362,7113,6809,6174],0); -ELEMENTS[43439] = Fluid3D([16419,16670,16558,16176],0); -ELEMENTS[43440] = Fluid3D([16342,16253,16471,16915],0); -ELEMENTS[43441] = Fluid3D([6030,5871,6432,5839],0); -ELEMENTS[43442] = Fluid3D([13606,12829,12908,13516],0); -ELEMENTS[43443] = Fluid3D([13606,12829,13516,14021],0); -ELEMENTS[43444] = Fluid3D([15394,15188,14910,14488],0); -ELEMENTS[43445] = Fluid3D([13688,13884,13885,13306],0); -ELEMENTS[43446] = Fluid3D([13885,13688,13306,13403],0); -ELEMENTS[43447] = Fluid3D([13306,13885,13403,14155],0); -ELEMENTS[43448] = Fluid3D([13306,13885,14155,13449],0); -ELEMENTS[43449] = Fluid3D([13306,13885,13449,13736],0); -ELEMENTS[43450] = Fluid3D([13306,13885,13736,13884],0); -ELEMENTS[43451] = Fluid3D([4943,4461,5046,4924],0); -ELEMENTS[43452] = Fluid3D([7806,7924,7608,8547],0); -ELEMENTS[43453] = Fluid3D([9088,9877,9855,9178],0); -ELEMENTS[43454] = Fluid3D([17316,17542,17065,17032],0); -ELEMENTS[43455] = Fluid3D([2272,2407,2532,2910],0); -ELEMENTS[43456] = Fluid3D([12447,12484,13366,12546],0); -ELEMENTS[43457] = Fluid3D([14546,13875,14664,14310],0); -ELEMENTS[43458] = Fluid3D([13875,14664,14310,14065],0); -ELEMENTS[43459] = Fluid3D([1727,1869,1888,1831],0); -ELEMENTS[43460] = Fluid3D([10925,10374,10006,10367],0); -ELEMENTS[43461] = Fluid3D([10925,10374,10367,10225],0); -ELEMENTS[43462] = Fluid3D([10374,10367,10225,9404],0); -ELEMENTS[43463] = Fluid3D([10367,10225,9404,10299],0); -ELEMENTS[43464] = Fluid3D([10367,10225,10299,11667],0); -ELEMENTS[43465] = Fluid3D([9404,10367,10299,10006],0); -ELEMENTS[43466] = Fluid3D([10374,10006,10367,9404],0); -ELEMENTS[43467] = Fluid3D([10367,10299,10006,10925],0); -ELEMENTS[43468] = Fluid3D([14775,13799,14043,14319],0); -ELEMENTS[43469] = Fluid3D([14043,14775,14319,14807],0); -ELEMENTS[43470] = Fluid3D([14775,13799,14319,14564],0); -ELEMENTS[43471] = Fluid3D([13799,14043,14319,13626],0); -ELEMENTS[43472] = Fluid3D([13792,13778,13271,13030],0); -ELEMENTS[43473] = Fluid3D([13778,13271,13030,12813],0); -ELEMENTS[43474] = Fluid3D([13792,13778,13030,14018],0); -ELEMENTS[43475] = Fluid3D([11760,11705,11204,10859],0); -ELEMENTS[43476] = Fluid3D([17709,17423,17898,17654],0); -ELEMENTS[43477] = Fluid3D([2626,2774,2546,3108],0); -ELEMENTS[43478] = Fluid3D([5635,5571,5611,4907],0); -ELEMENTS[43479] = Fluid3D([4465,5164,4669,4693],0); -ELEMENTS[43480] = Fluid3D([7754,8373,8029,7918],0); -ELEMENTS[43481] = Fluid3D([13655,13364,14139,14140],0); -ELEMENTS[43482] = Fluid3D([8968,9644,9741,8666],0); -ELEMENTS[43483] = Fluid3D([4821,5052,5129,4392],0); -ELEMENTS[43484] = Fluid3D([4413,4048,4431,4606],0); -ELEMENTS[43485] = Fluid3D([13184,14051,14232,13275],0); -ELEMENTS[43486] = Fluid3D([2588,2648,2639,2338],0); -ELEMENTS[43487] = Fluid3D([17224,17232,16790,17045],0); -ELEMENTS[43488] = Fluid3D([11933,12106,11201,11436],0); -ELEMENTS[43489] = Fluid3D([11450,11797,10716,10543],0); -ELEMENTS[43490] = Fluid3D([18370,18215,18206,18165],0); -ELEMENTS[43491] = Fluid3D([11699,10737,11405,11390],0); -ELEMENTS[43492] = Fluid3D([11643,11532,10817,12140],0); -ELEMENTS[43493] = Fluid3D([11103,11409,11060,10131],0); -ELEMENTS[43494] = Fluid3D([12661,13024,12427,11979],0); -ELEMENTS[43495] = Fluid3D([4326,3885,3829,3982],0); -ELEMENTS[43496] = Fluid3D([3829,4326,3982,4206],0); -ELEMENTS[43497] = Fluid3D([14103,14426,14507,13349],0); -ELEMENTS[43498] = Fluid3D([14024,13142,13419,13627],0); -ELEMENTS[43499] = Fluid3D([14024,13142,13627,13851],0); -ELEMENTS[43500] = Fluid3D([13142,13419,13627,13309],0); -ELEMENTS[43501] = Fluid3D([13627,13142,13309,13851],0); -ELEMENTS[43502] = Fluid3D([13309,13627,13851,14148],0); -ELEMENTS[43503] = Fluid3D([13309,13627,14148,13419],0); -ELEMENTS[43504] = Fluid3D([11638,10850,10288,11212],0); -ELEMENTS[43505] = Fluid3D([8947,8869,8291,9392],0); -ELEMENTS[43506] = Fluid3D([15381,14774,15229,15422],0); -ELEMENTS[43507] = Fluid3D([14774,15229,15422,15273],0); -ELEMENTS[43508] = Fluid3D([15229,15422,15273,15779],0); -ELEMENTS[43509] = Fluid3D([15381,14774,15422,15022],0); -ELEMENTS[43510] = Fluid3D([15273,15229,15779,15133],0); -ELEMENTS[43511] = Fluid3D([16904,16707,17159,17133],0); -ELEMENTS[43512] = Fluid3D([6144,6557,6821,6966],0); -ELEMENTS[43513] = Fluid3D([13783,13427,13643,12714],0); -ELEMENTS[43514] = Fluid3D([18124,18223,18037,18325],0); -ELEMENTS[43515] = Fluid3D([6723,6794,6329,6792],0); -ELEMENTS[43516] = Fluid3D([14211,14583,14231,15190],0); -ELEMENTS[43517] = Fluid3D([12443,11460,12217,12228],0); -ELEMENTS[43518] = Fluid3D([17237,17405,17565,17258],0); -ELEMENTS[43519] = Fluid3D([18444,18305,18414,18495],0); -ELEMENTS[43520] = Fluid3D([7829,7921,7842,7208],0); -ELEMENTS[43521] = Fluid3D([7842,7829,7208,6953],0); -ELEMENTS[43522] = Fluid3D([7829,7208,6953,7921],0); -ELEMENTS[43523] = Fluid3D([14257,14691,13941,14447],0); -ELEMENTS[43524] = Fluid3D([16205,16479,15774,16314],0); -ELEMENTS[43525] = Fluid3D([11240,10358,11280,10860],0); -ELEMENTS[43526] = Fluid3D([15264,14619,15070,14766],0); -ELEMENTS[43527] = Fluid3D([16199,16692,16454,16275],0); -ELEMENTS[43528] = Fluid3D([3698,3738,3308,3770],0); -ELEMENTS[43529] = Fluid3D([15344,15394,15947,15178],0); -ELEMENTS[43530] = Fluid3D([15394,15947,15178,15514],0); -ELEMENTS[43531] = Fluid3D([15327,14886,14611,15125],0); -ELEMENTS[43532] = Fluid3D([5702,5414,5057,5334],0); -ELEMENTS[43533] = Fluid3D([15316,16034,15859,16291],0); -ELEMENTS[43534] = Fluid3D([6993,6111,6497,6131],0); -ELEMENTS[43535] = Fluid3D([10894,10924,9971,10848],0); -ELEMENTS[43536] = Fluid3D([17134,17046,16967,16650],0); -ELEMENTS[43537] = Fluid3D([5617,5590,5470,6090],0); -ELEMENTS[43538] = Fluid3D([11442,11868,12435,12519],0); -ELEMENTS[43539] = Fluid3D([13244,12517,12519,12039],0); -ELEMENTS[43540] = Fluid3D([18074,18138,18202,18298],0); -ELEMENTS[43541] = Fluid3D([18202,18074,18298,18228],0); -ELEMENTS[43542] = Fluid3D([18298,18202,18228,18477],0); -ELEMENTS[43543] = Fluid3D([18138,18202,18298,18424],0); -ELEMENTS[43544] = Fluid3D([17879,17626,17924,17986],0); -ELEMENTS[43545] = Fluid3D([11204,10473,10133,11009],0); -ELEMENTS[43546] = Fluid3D([8370,8767,9614,9445],0); -ELEMENTS[43547] = Fluid3D([8767,9614,9445,9802],0); -ELEMENTS[43548] = Fluid3D([9614,9445,9802,10282],0); -ELEMENTS[43549] = Fluid3D([9614,9445,10282,9724],0); -ELEMENTS[43550] = Fluid3D([9614,8370,9445,9028],0); -ELEMENTS[43551] = Fluid3D([6950,6367,6112,6476],0); -ELEMENTS[43552] = Fluid3D([8639,7992,8250,7618],0); -ELEMENTS[43553] = Fluid3D([14685,14882,15108,14390],0); -ELEMENTS[43554] = Fluid3D([15135,15370,15579,15789],0); -ELEMENTS[43555] = Fluid3D([15135,15370,15789,15487],0); -ELEMENTS[43556] = Fluid3D([15789,15135,15487,15841],0); -ELEMENTS[43557] = Fluid3D([15579,15135,15789,15841],0); -ELEMENTS[43558] = Fluid3D([5002,4918,5100,5743],0); -ELEMENTS[43559] = Fluid3D([9974,9551,10632,10586],0); -ELEMENTS[43560] = Fluid3D([2601,2313,2453,2378],0); -ELEMENTS[43561] = Fluid3D([16260,15842,16246,16609],0); -ELEMENTS[43562] = Fluid3D([13993,13898,14589,13858],0); -ELEMENTS[43563] = Fluid3D([4225,4067,4100,3591],0); -ELEMENTS[43564] = Fluid3D([11965,11893,11274,12478],0); -ELEMENTS[43565] = Fluid3D([6934,6954,7595,7916],0); -ELEMENTS[43566] = Fluid3D([18183,18230,17979,18012],0); -ELEMENTS[43567] = Fluid3D([6213,5595,5969,5590],0); -ELEMENTS[43568] = Fluid3D([6937,7574,6730,7273],0); -ELEMENTS[43569] = Fluid3D([13175,13740,13940,14181],0); -ELEMENTS[43570] = Fluid3D([11567,12261,11429,11489],0); -ELEMENTS[43571] = Fluid3D([9389,10267,9846,8977],0); -ELEMENTS[43572] = Fluid3D([7650,7037,7502,6981],0); -ELEMENTS[43573] = Fluid3D([7650,7037,6981,6688],0); -ELEMENTS[43574] = Fluid3D([7037,7502,6981,6581],0); -ELEMENTS[43575] = Fluid3D([6981,7037,6581,6688],0); -ELEMENTS[43576] = Fluid3D([7502,6981,6581,7379],0); -ELEMENTS[43577] = Fluid3D([6981,6581,7379,7159],0); -ELEMENTS[43578] = Fluid3D([6981,6581,7159,6391],0); -ELEMENTS[43579] = Fluid3D([6981,6581,6391,6688],0); -ELEMENTS[43580] = Fluid3D([7159,6981,6391,7224],0); -ELEMENTS[43581] = Fluid3D([7159,6981,7224,7650],0); -ELEMENTS[43582] = Fluid3D([6981,7224,7650,6688],0); -ELEMENTS[43583] = Fluid3D([7224,7650,6688,7433],0); -ELEMENTS[43584] = Fluid3D([7224,7650,7433,8010],0); -ELEMENTS[43585] = Fluid3D([7224,7650,8010,7742],0); -ELEMENTS[43586] = Fluid3D([7433,7224,8010,7377],0); -ELEMENTS[43587] = Fluid3D([7224,7650,7742,7159],0); -ELEMENTS[43588] = Fluid3D([7742,7224,7159,7773],0); -ELEMENTS[43589] = Fluid3D([8010,7224,7742,7773],0); -ELEMENTS[43590] = Fluid3D([7224,8010,7377,7773],0); -ELEMENTS[43591] = Fluid3D([7650,7433,8010,7721],0); -ELEMENTS[43592] = Fluid3D([7650,8010,7742,8405],0); -ELEMENTS[43593] = Fluid3D([7650,8010,8405,7721],0); -ELEMENTS[43594] = Fluid3D([8010,7433,7377,8114],0); -ELEMENTS[43595] = Fluid3D([7377,8010,8114,7773],0); -ELEMENTS[43596] = Fluid3D([8010,7433,8114,7721],0); -ELEMENTS[43597] = Fluid3D([7433,7224,7377,7222],0); -ELEMENTS[43598] = Fluid3D([7377,7433,7222,8366],0); -ELEMENTS[43599] = Fluid3D([6688,7224,7433,7222],0); -ELEMENTS[43600] = Fluid3D([7159,7742,7773,7998],0); -ELEMENTS[43601] = Fluid3D([7159,7742,7998,7379],0); -ELEMENTS[43602] = Fluid3D([7433,7377,8114,8366],0); -ELEMENTS[43603] = Fluid3D([6981,6391,7224,6688],0); -ELEMENTS[43604] = Fluid3D([6391,7224,6688,6245],0); -ELEMENTS[43605] = Fluid3D([7650,7742,7159,6981],0); -ELEMENTS[43606] = Fluid3D([7742,7159,6981,7379],0); -ELEMENTS[43607] = Fluid3D([7650,7742,6981,7502],0); -ELEMENTS[43608] = Fluid3D([7650,7433,7721,7600],0); -ELEMENTS[43609] = Fluid3D([7433,7721,7600,6688],0); -ELEMENTS[43610] = Fluid3D([7650,7433,7600,6688],0); -ELEMENTS[43611] = Fluid3D([8010,7742,8405,8596],0); -ELEMENTS[43612] = Fluid3D([8010,7742,8596,8324],0); -ELEMENTS[43613] = Fluid3D([7433,6688,7222,7721],0); -ELEMENTS[43614] = Fluid3D([7222,7433,7721,8366],0); -ELEMENTS[43615] = Fluid3D([7742,7773,7998,8596],0); -ELEMENTS[43616] = Fluid3D([7998,7742,8596,8312],0); -ELEMENTS[43617] = Fluid3D([11478,12246,12047,12354],0); -ELEMENTS[43618] = Fluid3D([5954,5947,6530,6220],0); -ELEMENTS[43619] = Fluid3D([12237,13072,12469,11922],0); -ELEMENTS[43620] = Fluid3D([12469,12237,11922,11656],0); -ELEMENTS[43621] = Fluid3D([12237,11922,11656,11233],0); -ELEMENTS[43622] = Fluid3D([11922,12469,11656,11548],0); -ELEMENTS[43623] = Fluid3D([10102,9950,9354,9297],0); -ELEMENTS[43624] = Fluid3D([9354,10102,9297,9047],0); -ELEMENTS[43625] = Fluid3D([10102,9950,9297,10250],0); -ELEMENTS[43626] = Fluid3D([9297,10102,10250,9983],0); -ELEMENTS[43627] = Fluid3D([9297,10102,9983,9047],0); -ELEMENTS[43628] = Fluid3D([10102,10250,9983,10958],0); -ELEMENTS[43629] = Fluid3D([5826,6044,6742,5914],0); -ELEMENTS[43630] = Fluid3D([2713,3052,2947,2620],0); -ELEMENTS[43631] = Fluid3D([15159,15697,15008,15161],0); -ELEMENTS[43632] = Fluid3D([9493,8727,9357,9335],0); -ELEMENTS[43633] = Fluid3D([5821,5304,6018,5838],0); -ELEMENTS[43634] = Fluid3D([3140,3098,3499,3458],0); -ELEMENTS[43635] = Fluid3D([7842,8635,8629,8811],0); -ELEMENTS[43636] = Fluid3D([5301,5685,5688,5326],0); -ELEMENTS[43637] = Fluid3D([5688,5301,5326,5175],0); -ELEMENTS[43638] = Fluid3D([5326,5688,5175,5284],0); -ELEMENTS[43639] = Fluid3D([5175,5326,5284,5007],0); -ELEMENTS[43640] = Fluid3D([5175,5326,5007,5301],0); -ELEMENTS[43641] = Fluid3D([5326,5284,5007,5685],0); -ELEMENTS[43642] = Fluid3D([5284,5175,5007,4566],0); -ELEMENTS[43643] = Fluid3D([5326,5007,5301,5685],0); -ELEMENTS[43644] = Fluid3D([5326,5284,5685,5688],0); -ELEMENTS[43645] = Fluid3D([5007,5175,5301,5238],0); -ELEMENTS[43646] = Fluid3D([5284,5007,5685,4832],0); -ELEMENTS[43647] = Fluid3D([5284,5007,4832,4566],0); -ELEMENTS[43648] = Fluid3D([5007,5175,5238,4537],0); -ELEMENTS[43649] = Fluid3D([5007,5175,4537,4566],0); -ELEMENTS[43650] = Fluid3D([10659,11452,11382,10051],0); -ELEMENTS[43651] = Fluid3D([16661,16669,16866,17228],0); -ELEMENTS[43652] = Fluid3D([11282,10479,11271,10432],0); -ELEMENTS[43653] = Fluid3D([7608,7192,6524,6634],0); -ELEMENTS[43654] = Fluid3D([2116,2282,2410,2240],0); -ELEMENTS[43655] = Fluid3D([5983,6256,5657,5428],0); -ELEMENTS[43656] = Fluid3D([17214,17395,17655,17628],0); -ELEMENTS[43657] = Fluid3D([17214,17395,17628,17376],0); -ELEMENTS[43658] = Fluid3D([17430,17478,17187,16950],0); -ELEMENTS[43659] = Fluid3D([12257,11450,12190,11729],0); -ELEMENTS[43660] = Fluid3D([7418,6946,7844,7634],0); -ELEMENTS[43661] = Fluid3D([6668,6688,7600,6941],0); -ELEMENTS[43662] = Fluid3D([12477,12764,12283,11519],0); -ELEMENTS[43663] = Fluid3D([12683,13556,13014,12995],0); -ELEMENTS[43664] = Fluid3D([13556,13014,12995,13784],0); -ELEMENTS[43665] = Fluid3D([10205,10133,11009,10924],0); -ELEMENTS[43666] = Fluid3D([11594,12479,11716,12159],0); -ELEMENTS[43667] = Fluid3D([4977,4807,5415,5165],0); -ELEMENTS[43668] = Fluid3D([4807,5415,5165,5197],0); -ELEMENTS[43669] = Fluid3D([5165,4807,5197,4624],0); -ELEMENTS[43670] = Fluid3D([12237,12660,12438,11656],0); -ELEMENTS[43671] = Fluid3D([3087,2820,2932,2843],0); -ELEMENTS[43672] = Fluid3D([9211,8295,8874,8813],0); -ELEMENTS[43673] = Fluid3D([16277,15744,16209,15808],0); -ELEMENTS[43674] = Fluid3D([13160,13604,13149,12537],0); -ELEMENTS[43675] = Fluid3D([13503,12818,13488,13043],0); -ELEMENTS[43676] = Fluid3D([4441,4656,4171,4352],0); -ELEMENTS[43677] = Fluid3D([10433,10292,10273,11136],0); -ELEMENTS[43678] = Fluid3D([12278,12576,11582,12734],0); -ELEMENTS[43679] = Fluid3D([3205,2871,3164,2878],0); -ELEMENTS[43680] = Fluid3D([17035,16971,16542,16848],0); -ELEMENTS[43681] = Fluid3D([6072,5775,6312,6564],0); -ELEMENTS[43682] = Fluid3D([13368,12844,12612,12751],0); -ELEMENTS[43683] = Fluid3D([5783,5477,5178,5601],0); -ELEMENTS[43684] = Fluid3D([13231,13188,12948,13808],0); -ELEMENTS[43685] = Fluid3D([13188,12948,13808,13804],0); -ELEMENTS[43686] = Fluid3D([13808,13188,13804,13683],0); -ELEMENTS[43687] = Fluid3D([12948,13808,13804,14074],0); -ELEMENTS[43688] = Fluid3D([13808,13804,14074,14542],0); -ELEMENTS[43689] = Fluid3D([13808,13804,14542,13683],0); -ELEMENTS[43690] = Fluid3D([14074,13808,14542,14189],0); -ELEMENTS[43691] = Fluid3D([14074,13808,14189,13262],0); -ELEMENTS[43692] = Fluid3D([14074,13808,13262,12948],0); -ELEMENTS[43693] = Fluid3D([13808,14189,13262,13231],0); -ELEMENTS[43694] = Fluid3D([13262,13808,13231,12948],0); -ELEMENTS[43695] = Fluid3D([13231,13262,12948,12561],0); -ELEMENTS[43696] = Fluid3D([14189,13262,13231,13824],0); -ELEMENTS[43697] = Fluid3D([13262,13231,13824,13314],0); -ELEMENTS[43698] = Fluid3D([13808,14189,13231,13188],0); -ELEMENTS[43699] = Fluid3D([13808,14542,14189,13683],0); -ELEMENTS[43700] = Fluid3D([13804,14074,14542,14449],0); -ELEMENTS[43701] = Fluid3D([14189,13808,13683,13188],0); -ELEMENTS[43702] = Fluid3D([13231,14189,13824,13532],0); -ELEMENTS[43703] = Fluid3D([13824,13231,13532,12664],0); -ELEMENTS[43704] = Fluid3D([14189,14074,13262,13690],0); -ELEMENTS[43705] = Fluid3D([14074,13262,13690,13601],0); -ELEMENTS[43706] = Fluid3D([13262,14189,13690,13824],0); -ELEMENTS[43707] = Fluid3D([13262,13690,13601,13202],0); -ELEMENTS[43708] = Fluid3D([13690,13262,13824,13314],0); -ELEMENTS[43709] = Fluid3D([13262,13690,13202,13314],0); -ELEMENTS[43710] = Fluid3D([16886,16783,17248,16834],0); -ELEMENTS[43711] = Fluid3D([16886,16783,16834,16246],0); -ELEMENTS[43712] = Fluid3D([10349,9542,9581,10193],0); -ELEMENTS[43713] = Fluid3D([9542,9581,10193,8874],0); -ELEMENTS[43714] = Fluid3D([10349,9542,10193,10099],0); -ELEMENTS[43715] = Fluid3D([7858,7406,7731,7022],0); -ELEMENTS[43716] = Fluid3D([12654,13563,13011,12721],0); -ELEMENTS[43717] = Fluid3D([18232,18087,18307,18011],0); -ELEMENTS[43718] = Fluid3D([6955,7541,6966,6821],0); -ELEMENTS[43719] = Fluid3D([14610,13848,14029,14251],0); -ELEMENTS[43720] = Fluid3D([16407,15810,16020,15432],0); -ELEMENTS[43721] = Fluid3D([16446,16149,16696,16574],0); -ELEMENTS[43722] = Fluid3D([4126,4071,4303,3812],0); -ELEMENTS[43723] = Fluid3D([10043,9821,10527,10638],0); -ELEMENTS[43724] = Fluid3D([10889,10783,11630,11541],0); -ELEMENTS[43725] = Fluid3D([6009,6321,5516,5916],0); -ELEMENTS[43726] = Fluid3D([8372,8999,9293,8585],0); -ELEMENTS[43727] = Fluid3D([9306,8935,9533,8702],0); -ELEMENTS[43728] = Fluid3D([6169,6264,5771,6615],0); -ELEMENTS[43729] = Fluid3D([9644,10461,9608,9585],0); -ELEMENTS[43730] = Fluid3D([7674,7141,8091,7221],0); -ELEMENTS[43731] = Fluid3D([7674,7141,7221,6725],0); -ELEMENTS[43732] = Fluid3D([7488,7098,7351,7966],0); -ELEMENTS[43733] = Fluid3D([17652,17756,17497,17514],0); -ELEMENTS[43734] = Fluid3D([13061,13634,12637,13155],0); -ELEMENTS[43735] = Fluid3D([12850,13098,12199,12808],0); -ELEMENTS[43736] = Fluid3D([10252,10624,10009,9677],0); -ELEMENTS[43737] = Fluid3D([17749,17656,17350,17338],0); -ELEMENTS[43738] = Fluid3D([18263,18327,18323,18456],0); -ELEMENTS[43739] = Fluid3D([18263,18327,18456,18455],0); -ELEMENTS[43740] = Fluid3D([6655,6839,7036,7676],0); -ELEMENTS[43741] = Fluid3D([12163,12740,12911,13012],0); -ELEMENTS[43742] = Fluid3D([9377,8848,8845,9780],0); -ELEMENTS[43743] = Fluid3D([8384,7704,8542,8491],0); -ELEMENTS[43744] = Fluid3D([12615,11861,12613,13014],0); -ELEMENTS[43745] = Fluid3D([17503,17223,17597,17541],0); -ELEMENTS[43746] = Fluid3D([17503,17223,17541,17276],0); -ELEMENTS[43747] = Fluid3D([17597,17503,17541,17893],0); -ELEMENTS[43748] = Fluid3D([17541,17503,17276,17686],0); -ELEMENTS[43749] = Fluid3D([17541,17503,17686,17893],0); -ELEMENTS[43750] = Fluid3D([14571,14793,15132,14229],0); -ELEMENTS[43751] = Fluid3D([14571,14793,14229,14072],0); -ELEMENTS[43752] = Fluid3D([15132,14571,14229,15059],0); -ELEMENTS[43753] = Fluid3D([16523,16957,16873,16816],0); -ELEMENTS[43754] = Fluid3D([6236,6068,6741,6878],0); -ELEMENTS[43755] = Fluid3D([13677,13393,14070,13077],0); -ELEMENTS[43756] = Fluid3D([13885,14424,13736,13884],0); -ELEMENTS[43757] = Fluid3D([13742,14382,14062,13297],0); -ELEMENTS[43758] = Fluid3D([5346,5835,5661,5878],0); -ELEMENTS[43759] = Fluid3D([15849,15833,16449,16253],0); -ELEMENTS[43760] = Fluid3D([5778,5728,5206,5345],0); -ELEMENTS[43761] = Fluid3D([7804,8578,7978,7808],0); -ELEMENTS[43762] = Fluid3D([18038,18294,18096,18063],0); -ELEMENTS[43763] = Fluid3D([16186,16070,15588,15898],0); -ELEMENTS[43764] = Fluid3D([14911,14382,14532,14984],0); -ELEMENTS[43765] = Fluid3D([14911,14382,14984,15335],0); -ELEMENTS[43766] = Fluid3D([8095,8389,8926,8665],0); -ELEMENTS[43767] = Fluid3D([18117,18004,17925,18306],0); -ELEMENTS[43768] = Fluid3D([17171,17247,17020,16807],0); -ELEMENTS[43769] = Fluid3D([11925,11376,12321,11984],0); -ELEMENTS[43770] = Fluid3D([6762,7317,7014,7795],0); -ELEMENTS[43771] = Fluid3D([13770,13071,13887,14210],0); -ELEMENTS[43772] = Fluid3D([11499,12481,11554,12047],0); -ELEMENTS[43773] = Fluid3D([9226,10306,9943,9184],0); -ELEMENTS[43774] = Fluid3D([6402,6335,7235,6164],0); -ELEMENTS[43775] = Fluid3D([3184,3129,3605,3295],0); -ELEMENTS[43776] = Fluid3D([3184,3129,3295,2892],0); -ELEMENTS[43777] = Fluid3D([3129,3605,3295,3472],0); -ELEMENTS[43778] = Fluid3D([3295,3129,3472,3150],0); -ELEMENTS[43779] = Fluid3D([3295,3129,3150,2892],0); -ELEMENTS[43780] = Fluid3D([3129,3472,3150,3206],0); -ELEMENTS[43781] = Fluid3D([3472,3295,3150,3320],0); -ELEMENTS[43782] = Fluid3D([4595,4650,4314,4850],0); -ELEMENTS[43783] = Fluid3D([14163,13975,13691,14613],0); -ELEMENTS[43784] = Fluid3D([14957,14904,14383,13810],0); -ELEMENTS[43785] = Fluid3D([13566,12986,13177,12382],0); -ELEMENTS[43786] = Fluid3D([4164,4127,4387,3851],0); -ELEMENTS[43787] = Fluid3D([10474,11271,11164,10479],0); -ELEMENTS[43788] = Fluid3D([5951,5395,5585,4934],0); -ELEMENTS[43789] = Fluid3D([5602,5269,5187,4791],0); -ELEMENTS[43790] = Fluid3D([16481,16897,17028,16806],0); -ELEMENTS[43791] = Fluid3D([11053,11229,10768,11908],0); -ELEMENTS[43792] = Fluid3D([14476,14717,14716,13949],0); -ELEMENTS[43793] = Fluid3D([2733,2911,3117,2976],0); -ELEMENTS[43794] = Fluid3D([9628,10085,10769,10414],0); -ELEMENTS[43795] = Fluid3D([13864,13609,13077,13743],0); -ELEMENTS[43796] = Fluid3D([17845,17573,17430,17750],0); -ELEMENTS[43797] = Fluid3D([10438,10091,9383,9786],0); -ELEMENTS[43798] = Fluid3D([10438,10091,9786,11472],0); -ELEMENTS[43799] = Fluid3D([10091,9383,9786,8614],0); -ELEMENTS[43800] = Fluid3D([7604,7260,8252,7852],0); -ELEMENTS[43801] = Fluid3D([7555,8307,8069,7550],0); -ELEMENTS[43802] = Fluid3D([14053,13551,13976,14310],0); -ELEMENTS[43803] = Fluid3D([17659,17271,17464,17646],0); -ELEMENTS[43804] = Fluid3D([4708,4779,5124,5323],0); -ELEMENTS[43805] = Fluid3D([6092,6893,6600,6868],0); -ELEMENTS[43806] = Fluid3D([1861,1880,1956,2098],0); -ELEMENTS[43807] = Fluid3D([4699,4465,4669,4209],0); -ELEMENTS[43808] = Fluid3D([4669,4699,4209,4386],0); -ELEMENTS[43809] = Fluid3D([4209,4669,4386,4363],0); -ELEMENTS[43810] = Fluid3D([4699,4209,4386,4426],0); -ELEMENTS[43811] = Fluid3D([4699,4465,4209,4051],0); -ELEMENTS[43812] = Fluid3D([4465,4209,4051,4150],0); -ELEMENTS[43813] = Fluid3D([4209,4699,4051,3983],0); -ELEMENTS[43814] = Fluid3D([4051,4209,3983,3950],0); -ELEMENTS[43815] = Fluid3D([4051,4209,3950,4150],0); -ELEMENTS[43816] = Fluid3D([4669,4386,4363,4800],0); -ELEMENTS[43817] = Fluid3D([14373,14151,13558,13374],0); -ELEMENTS[43818] = Fluid3D([15112,15756,15921,15003],0); -ELEMENTS[43819] = Fluid3D([6207,5770,5942,6715],0); -ELEMENTS[43820] = Fluid3D([12668,12374,12430,13254],0); -ELEMENTS[43821] = Fluid3D([18333,18429,18238,18252],0); -ELEMENTS[43822] = Fluid3D([11147,11523,11327,10542],0); -ELEMENTS[43823] = Fluid3D([15956,15343,15396,15632],0); -ELEMENTS[43824] = Fluid3D([7984,8396,7870,7368],0); -ELEMENTS[43825] = Fluid3D([16834,17252,16977,17248],0); -ELEMENTS[43826] = Fluid3D([8808,9647,9659,9860],0); -ELEMENTS[43827] = Fluid3D([15503,15582,15600,16155],0); -ELEMENTS[43828] = Fluid3D([15503,15582,16155,16306],0); -ELEMENTS[43829] = Fluid3D([18510,18525,18603,18431],0); -ELEMENTS[43830] = Fluid3D([11558,12029,12364,12433],0); -ELEMENTS[43831] = Fluid3D([16318,16284,16779,16335],0); -ELEMENTS[43832] = Fluid3D([5670,5208,5495,5819],0); -ELEMENTS[43833] = Fluid3D([5208,5495,5819,5242],0); -ELEMENTS[43834] = Fluid3D([5495,5819,5242,6024],0); -ELEMENTS[43835] = Fluid3D([5495,5819,6024,5911],0); -ELEMENTS[43836] = Fluid3D([5495,5819,5911,5873],0); -ELEMENTS[43837] = Fluid3D([5495,5819,5873,5670],0); -ELEMENTS[43838] = Fluid3D([5911,5495,5873,5946],0); -ELEMENTS[43839] = Fluid3D([5873,5911,5946,6632],0); -ELEMENTS[43840] = Fluid3D([5911,5946,6632,6145],0); -ELEMENTS[43841] = Fluid3D([5911,5946,6145,5548],0); -ELEMENTS[43842] = Fluid3D([6632,5911,6145,6574],0); -ELEMENTS[43843] = Fluid3D([6632,5911,6574,6542],0); -ELEMENTS[43844] = Fluid3D([5819,5873,5670,6311],0); -ELEMENTS[43845] = Fluid3D([5873,5670,6311,6209],0); -ELEMENTS[43846] = Fluid3D([5819,5873,6311,6542],0); -ELEMENTS[43847] = Fluid3D([6145,6632,6574,6907],0); -ELEMENTS[43848] = Fluid3D([6632,6574,6907,7453],0); -ELEMENTS[43849] = Fluid3D([6632,6574,7453,6542],0); -ELEMENTS[43850] = Fluid3D([6574,6907,7453,7269],0); -ELEMENTS[43851] = Fluid3D([16371,16095,16459,16016],0); -ELEMENTS[43852] = Fluid3D([16686,16987,16719,17057],0); -ELEMENTS[43853] = Fluid3D([5040,5355,5681,5474],0); -ELEMENTS[43854] = Fluid3D([17613,17952,17868,17843],0); -ELEMENTS[43855] = Fluid3D([15520,14949,15302,15751],0); -ELEMENTS[43856] = Fluid3D([7618,7164,6659,7556],0); -ELEMENTS[43857] = Fluid3D([6659,7618,7556,6664],0); -ELEMENTS[43858] = Fluid3D([6464,6182,6302,6953],0); -ELEMENTS[43859] = Fluid3D([13066,11992,12405,12387],0); -ELEMENTS[43860] = Fluid3D([16979,17288,16860,17312],0); -ELEMENTS[43861] = Fluid3D([17288,16860,17312,17363],0); -ELEMENTS[43862] = Fluid3D([17312,17288,17363,17730],0); -ELEMENTS[43863] = Fluid3D([16655,16348,16323,16157],0); -ELEMENTS[43864] = Fluid3D([3124,2964,3369,3112],0); -ELEMENTS[43865] = Fluid3D([15343,14692,14642,14603],0); -ELEMENTS[43866] = Fluid3D([10401,10846,9839,11019],0); -ELEMENTS[43867] = Fluid3D([18143,18178,17948,18148],0); -ELEMENTS[43868] = Fluid3D([17948,18143,18148,17876],0); -ELEMENTS[43869] = Fluid3D([17590,17623,17874,17972],0); -ELEMENTS[43870] = Fluid3D([14387,14165,14719,15005],0); -ELEMENTS[43871] = Fluid3D([9918,9028,9157,9614],0); -ELEMENTS[43872] = Fluid3D([14490,13694,14646,14899],0); -ELEMENTS[43873] = Fluid3D([5044,4901,4542,5108],0); -ELEMENTS[43874] = Fluid3D([4901,4542,5108,4811],0); -ELEMENTS[43875] = Fluid3D([14000,14626,15072,14025],0); -ELEMENTS[43876] = Fluid3D([14686,14625,15364,14812],0); -ELEMENTS[43877] = Fluid3D([12570,12256,11787,11289],0); -ELEMENTS[43878] = Fluid3D([16456,15983,16227,16231],0); -ELEMENTS[43879] = Fluid3D([4461,4705,5046,4240],0); -ELEMENTS[43880] = Fluid3D([3077,3073,3019,2772],0); -ELEMENTS[43881] = Fluid3D([18524,18388,18407,18387],0); -ELEMENTS[43882] = Fluid3D([14379,13643,14291,14604],0); -ELEMENTS[43883] = Fluid3D([8731,9596,9448,8680],0); -ELEMENTS[43884] = Fluid3D([12746,12112,13137,12962],0); -ELEMENTS[43885] = Fluid3D([12112,13137,12962,12255],0); -ELEMENTS[43886] = Fluid3D([16463,16228,16616,16075],0); -ELEMENTS[43887] = Fluid3D([12327,12645,11721,12719],0); -ELEMENTS[43888] = Fluid3D([10857,11438,10421,10604],0); -ELEMENTS[43889] = Fluid3D([17574,17746,17452,17394],0); -ELEMENTS[43890] = Fluid3D([14253,14188,13954,14944],0); -ELEMENTS[43891] = Fluid3D([11351,12245,11428,11509],0); -ELEMENTS[43892] = Fluid3D([6802,7071,7711,6925],0); -ELEMENTS[43893] = Fluid3D([18151,18262,18402,18251],0); -ELEMENTS[43894] = Fluid3D([18151,18262,18251,18164],0); -ELEMENTS[43895] = Fluid3D([18262,18402,18251,18386],0); -ELEMENTS[43896] = Fluid3D([18251,18262,18386,18164],0); -ELEMENTS[43897] = Fluid3D([18262,18386,18164,18335],0); -ELEMENTS[43898] = Fluid3D([18262,18386,18335,18418],0); -ELEMENTS[43899] = Fluid3D([18386,18335,18418,18380],0); -ELEMENTS[43900] = Fluid3D([18262,18386,18418,18402],0); -ELEMENTS[43901] = Fluid3D([18386,18164,18335,18331],0); -ELEMENTS[43902] = Fluid3D([18335,18386,18331,18380],0); -ELEMENTS[43903] = Fluid3D([18164,18335,18331,18082],0); -ELEMENTS[43904] = Fluid3D([11440,11756,12482,11732],0); -ELEMENTS[43905] = Fluid3D([16428,16125,15806,16431],0); -ELEMENTS[43906] = Fluid3D([6874,6892,6177,6137],0); -ELEMENTS[43907] = Fluid3D([3549,3817,3848,3471],0); -ELEMENTS[43908] = Fluid3D([8678,7924,8305,8428],0); -ELEMENTS[43909] = Fluid3D([10835,11403,11423,11843],0); -ELEMENTS[43910] = Fluid3D([16140,16134,15637,15988],0); -ELEMENTS[43911] = Fluid3D([15637,16140,15988,15669],0); -ELEMENTS[43912] = Fluid3D([16140,15988,15669,15897],0); -ELEMENTS[43913] = Fluid3D([15988,15637,15669,15346],0); -ELEMENTS[43914] = Fluid3D([16140,16134,15988,16613],0); -ELEMENTS[43915] = Fluid3D([15988,16140,16613,16337],0); -ELEMENTS[43916] = Fluid3D([7900,8245,8542,8764],0); -ELEMENTS[43917] = Fluid3D([15900,16322,15841,16108],0); -ELEMENTS[43918] = Fluid3D([15900,16322,16108,16515],0); -ELEMENTS[43919] = Fluid3D([16108,15900,16515,16194],0); -ELEMENTS[43920] = Fluid3D([13144,13421,13451,14170],0); -ELEMENTS[43921] = Fluid3D([9827,9907,10593,9400],0); -ELEMENTS[43922] = Fluid3D([6762,6586,7263,6399],0); -ELEMENTS[43923] = Fluid3D([6762,6586,6399,5791],0); -ELEMENTS[43924] = Fluid3D([7263,6762,6399,7028],0); -ELEMENTS[43925] = Fluid3D([6762,6399,7028,6552],0); -ELEMENTS[43926] = Fluid3D([7028,6762,6552,7819],0); -ELEMENTS[43927] = Fluid3D([7263,6762,7028,7795],0); -ELEMENTS[43928] = Fluid3D([6762,7028,7795,7819],0); -ELEMENTS[43929] = Fluid3D([17252,17189,17510,17377],0); -ELEMENTS[43930] = Fluid3D([17252,17189,17377,17248],0); -ELEMENTS[43931] = Fluid3D([9311,9238,9378,8402],0); -ELEMENTS[43932] = Fluid3D([14118,13358,13829,14068],0); -ELEMENTS[43933] = Fluid3D([17393,17385,17378,17751],0); -ELEMENTS[43934] = Fluid3D([3327,3180,3559,3661],0); -ELEMENTS[43935] = Fluid3D([3559,3327,3661,3916],0); -ELEMENTS[43936] = Fluid3D([16674,17128,16807,16985],0); -ELEMENTS[43937] = Fluid3D([13707,13785,14264,13334],0); -ELEMENTS[43938] = Fluid3D([11074,11078,10741,12072],0); -ELEMENTS[43939] = Fluid3D([12614,11904,12376,12988],0); -ELEMENTS[43940] = Fluid3D([5347,5243,4830,5285],0); -ELEMENTS[43941] = Fluid3D([17889,17874,18015,18266],0); -ELEMENTS[43942] = Fluid3D([11664,12504,12378,11730],0); -ELEMENTS[43943] = Fluid3D([11664,12504,11730,11219],0); -ELEMENTS[43944] = Fluid3D([12504,12378,11730,12647],0); -ELEMENTS[43945] = Fluid3D([12378,11664,11730,11523],0); -ELEMENTS[43946] = Fluid3D([11730,12378,11523,12647],0); -ELEMENTS[43947] = Fluid3D([12504,11730,11219,11350],0); -ELEMENTS[43948] = Fluid3D([12504,11730,11350,12237],0); -ELEMENTS[43949] = Fluid3D([11730,11664,11219,10962],0); -ELEMENTS[43950] = Fluid3D([3056,3316,3248,2930],0); -ELEMENTS[43951] = Fluid3D([3056,3316,2930,3000],0); -ELEMENTS[43952] = Fluid3D([9513,10027,9371,10310],0); -ELEMENTS[43953] = Fluid3D([5038,5489,5586,4968],0); -ELEMENTS[43954] = Fluid3D([5667,5159,5450,5650],0); -ELEMENTS[43955] = Fluid3D([5667,5159,5650,5146],0); -ELEMENTS[43956] = Fluid3D([5159,5450,5650,4948],0); -ELEMENTS[43957] = Fluid3D([5650,5159,4948,4876],0); -ELEMENTS[43958] = Fluid3D([4948,5650,4876,5153],0); -ELEMENTS[43959] = Fluid3D([16490,16384,16720,16876],0); -ELEMENTS[43960] = Fluid3D([16720,16490,16876,17076],0); -ELEMENTS[43961] = Fluid3D([16490,16384,16876,16350],0); -ELEMENTS[43962] = Fluid3D([15295,14533,14748,14506],0); -ELEMENTS[43963] = Fluid3D([17638,17590,17889,17972],0); -ELEMENTS[43964] = Fluid3D([13623,14186,13322,13593],0); -ELEMENTS[43965] = Fluid3D([14843,15468,15122,15659],0); -ELEMENTS[43966] = Fluid3D([7401,7541,6955,6821],0); -ELEMENTS[43967] = Fluid3D([18648,18627,18663,18679],0); -ELEMENTS[43968] = Fluid3D([16472,16761,16232,16473],0); -ELEMENTS[43969] = Fluid3D([2954,2890,3050,3175],0); -ELEMENTS[43970] = Fluid3D([2954,2890,3175,3071],0); -ELEMENTS[43971] = Fluid3D([2890,3050,3175,2988],0); -ELEMENTS[43972] = Fluid3D([3175,2890,2988,2981],0); -ELEMENTS[43973] = Fluid3D([6887,7665,7454,6618],0); -ELEMENTS[43974] = Fluid3D([5996,6368,5915,5615],0); -ELEMENTS[43975] = Fluid3D([2223,2381,2495,2269],0); -ELEMENTS[43976] = Fluid3D([2381,2495,2269,2517],0); -ELEMENTS[43977] = Fluid3D([2223,2381,2269,2018],0); -ELEMENTS[43978] = Fluid3D([6804,6287,7300,7077],0); -ELEMENTS[43979] = Fluid3D([6287,7300,7077,6592],0); -ELEMENTS[43980] = Fluid3D([7300,6804,7077,7616],0); -ELEMENTS[43981] = Fluid3D([15966,15613,15301,15417],0); -ELEMENTS[43982] = Fluid3D([15613,15301,15417,14931],0); -ELEMENTS[43983] = Fluid3D([15417,15613,14931,15920],0); -ELEMENTS[43984] = Fluid3D([15966,15613,15417,16239],0); -ELEMENTS[43985] = Fluid3D([10652,10862,10214,9583],0); -ELEMENTS[43986] = Fluid3D([9407,9116,10122,9861],0); -ELEMENTS[43987] = Fluid3D([10548,10571,9998,11146],0); -ELEMENTS[43988] = Fluid3D([10548,10571,11146,11647],0); -ELEMENTS[43989] = Fluid3D([6504,6294,7126,6802],0); -ELEMENTS[43990] = Fluid3D([6512,6572,6247,7036],0); -ELEMENTS[43991] = Fluid3D([2838,2548,2812,2736],0); -ELEMENTS[43992] = Fluid3D([2548,2812,2736,2456],0); -ELEMENTS[43993] = Fluid3D([2812,2838,2736,3210],0); -ELEMENTS[43994] = Fluid3D([2812,2736,2456,2628],0); -ELEMENTS[43995] = Fluid3D([2736,2812,3210,3314],0); -ELEMENTS[43996] = Fluid3D([2812,2736,2628,3314],0); -ELEMENTS[43997] = Fluid3D([18035,18284,18105,18225],0); -ELEMENTS[43998] = Fluid3D([10821,10904,11001,9932],0); -ELEMENTS[43999] = Fluid3D([7112,7291,7921,7208],0); -ELEMENTS[44000] = Fluid3D([7291,7921,7208,6669],0); -ELEMENTS[44001] = Fluid3D([7208,7291,6669,7112],0); -ELEMENTS[44002] = Fluid3D([17783,17825,17976,18167],0); -ELEMENTS[44003] = Fluid3D([2026,1881,2019,1985],0); -ELEMENTS[44004] = Fluid3D([2026,1881,1985,2012],0); -ELEMENTS[44005] = Fluid3D([2026,1881,2012,2034],0); -ELEMENTS[44006] = Fluid3D([2012,2026,2034,2193],0); -ELEMENTS[44007] = Fluid3D([1881,1985,2012,1917],0); -ELEMENTS[44008] = Fluid3D([2012,1881,1917,1854],0); -ELEMENTS[44009] = Fluid3D([2026,1881,2034,1854],0); -ELEMENTS[44010] = Fluid3D([1985,2026,2012,2197],0); -ELEMENTS[44011] = Fluid3D([1881,2012,2034,1854],0); -ELEMENTS[44012] = Fluid3D([2034,2012,2193,2126],0); -ELEMENTS[44013] = Fluid3D([4976,5532,4827,4956],0); -ELEMENTS[44014] = Fluid3D([17878,17922,17945,18164],0); -ELEMENTS[44015] = Fluid3D([11168,11874,12241,11445],0); -ELEMENTS[44016] = Fluid3D([17754,18016,18040,17968],0); -ELEMENTS[44017] = Fluid3D([2670,2860,2538,2927],0); -ELEMENTS[44018] = Fluid3D([16369,16591,16947,16893],0); -ELEMENTS[44019] = Fluid3D([10824,11508,11401,10914],0); -ELEMENTS[44020] = Fluid3D([17416,17517,17105,17339],0); -ELEMENTS[44021] = Fluid3D([8774,8808,9659,8863],0); -ELEMENTS[44022] = Fluid3D([4744,4427,4962,4672],0); -ELEMENTS[44023] = Fluid3D([12477,11519,11622,12609],0); -ELEMENTS[44024] = Fluid3D([9787,10446,9717,10184],0); -ELEMENTS[44025] = Fluid3D([9787,10446,10184,10352],0); -ELEMENTS[44026] = Fluid3D([10446,10184,10352,11016],0); -ELEMENTS[44027] = Fluid3D([10352,10446,11016,11183],0); -ELEMENTS[44028] = Fluid3D([10352,10446,11183,10135],0); -ELEMENTS[44029] = Fluid3D([9717,9787,10184,9387],0); -ELEMENTS[44030] = Fluid3D([9717,9787,9387,8844],0); -ELEMENTS[44031] = Fluid3D([10446,10184,11016,10714],0); -ELEMENTS[44032] = Fluid3D([10446,10184,10714,9717],0); -ELEMENTS[44033] = Fluid3D([5258,5229,5566,4793],0); -ELEMENTS[44034] = Fluid3D([5309,4977,5415,5843],0); -ELEMENTS[44035] = Fluid3D([18249,18318,18031,18075],0); -ELEMENTS[44036] = Fluid3D([15252,14901,15468,15445],0); -ELEMENTS[44037] = Fluid3D([5664,6179,6109,5997],0); -ELEMENTS[44038] = Fluid3D([16301,15736,16195,16278],0); -ELEMENTS[44039] = Fluid3D([16301,15736,16278,16255],0); -ELEMENTS[44040] = Fluid3D([16195,16301,16278,16693],0); -ELEMENTS[44041] = Fluid3D([16301,16278,16693,16601],0); -ELEMENTS[44042] = Fluid3D([16195,16301,16693,16651],0); -ELEMENTS[44043] = Fluid3D([16278,16195,16693,16446],0); -ELEMENTS[44044] = Fluid3D([2043,2187,1973,2137],0); -ELEMENTS[44045] = Fluid3D([2043,2187,2137,2235],0); -ELEMENTS[44046] = Fluid3D([2043,2187,2235,2144],0); -ELEMENTS[44047] = Fluid3D([2043,2187,2144,2219],0); -ELEMENTS[44048] = Fluid3D([14916,15228,14629,14310],0); -ELEMENTS[44049] = Fluid3D([11732,10679,10782,10757],0); -ELEMENTS[44050] = Fluid3D([5374,5572,5494,4840],0); -ELEMENTS[44051] = Fluid3D([6667,5897,6641,5986],0); -ELEMENTS[44052] = Fluid3D([14858,15105,15472,14808],0); -ELEMENTS[44053] = Fluid3D([6796,6966,6825,6075],0); -ELEMENTS[44054] = Fluid3D([2054,1897,2075,2008],0); -ELEMENTS[44055] = Fluid3D([1897,2075,2008,1856],0); -ELEMENTS[44056] = Fluid3D([2075,2054,2008,2182],0); -ELEMENTS[44057] = Fluid3D([4116,4214,4569,3989],0); -ELEMENTS[44058] = Fluid3D([4214,4569,3989,4231],0); -ELEMENTS[44059] = Fluid3D([4214,4569,4231,4724],0); -ELEMENTS[44060] = Fluid3D([4231,4214,4724,4259],0); -ELEMENTS[44061] = Fluid3D([4231,4214,4259,3712],0); -ELEMENTS[44062] = Fluid3D([4231,4214,3712,3802],0); -ELEMENTS[44063] = Fluid3D([4214,3712,3802,4116],0); -ELEMENTS[44064] = Fluid3D([4231,4214,3802,3989],0); -ELEMENTS[44065] = Fluid3D([7196,7648,7971,8289],0); -ELEMENTS[44066] = Fluid3D([6817,7202,6976,7635],0); -ELEMENTS[44067] = Fluid3D([8884,9113,10037,9839],0); -ELEMENTS[44068] = Fluid3D([4330,4747,4858,4913],0); -ELEMENTS[44069] = Fluid3D([5697,5980,5549,5384],0); -ELEMENTS[44070] = Fluid3D([5549,5697,5384,5643],0); -ELEMENTS[44071] = Fluid3D([5549,5697,5643,6084],0); -ELEMENTS[44072] = Fluid3D([5697,5980,5384,5921],0); -ELEMENTS[44073] = Fluid3D([5697,5643,6084,6375],0); -ELEMENTS[44074] = Fluid3D([5697,5384,5643,5393],0); -ELEMENTS[44075] = Fluid3D([5697,5384,5393,5921],0); -ELEMENTS[44076] = Fluid3D([5697,5643,6375,5949],0); -ELEMENTS[44077] = Fluid3D([5697,5643,5949,5393],0); -ELEMENTS[44078] = Fluid3D([6375,5697,5949,5921],0); -ELEMENTS[44079] = Fluid3D([14368,14752,14942,15120],0); -ELEMENTS[44080] = Fluid3D([13480,13153,12641,13198],0); -ELEMENTS[44081] = Fluid3D([12641,13480,13198,13616],0); -ELEMENTS[44082] = Fluid3D([13480,13153,13198,14237],0); -ELEMENTS[44083] = Fluid3D([2677,2728,2419,2703],0); -ELEMENTS[44084] = Fluid3D([13404,14025,14097,13101],0); -ELEMENTS[44085] = Fluid3D([13404,14025,13101,12767],0); -ELEMENTS[44086] = Fluid3D([4331,4335,4834,4272],0); -ELEMENTS[44087] = Fluid3D([4331,4335,4272,3832],0); -ELEMENTS[44088] = Fluid3D([2642,2925,2936,2973],0); -ELEMENTS[44089] = Fluid3D([10449,10753,10752,10014],0); -ELEMENTS[44090] = Fluid3D([10876,11886,11072,10853],0); -ELEMENTS[44091] = Fluid3D([11292,11900,12215,12525],0); -ELEMENTS[44092] = Fluid3D([11900,12215,12525,12287],0); -ELEMENTS[44093] = Fluid3D([11292,11900,12525,12418],0); -ELEMENTS[44094] = Fluid3D([7982,7713,7898,8220],0); -ELEMENTS[44095] = Fluid3D([14887,15432,15036,14974],0); -ELEMENTS[44096] = Fluid3D([15036,14887,14974,14132],0); -ELEMENTS[44097] = Fluid3D([15036,14887,14132,14500],0); -ELEMENTS[44098] = Fluid3D([10782,9860,10370,11188],0); -ELEMENTS[44099] = Fluid3D([4444,4567,4956,4520],0); -ELEMENTS[44100] = Fluid3D([4567,4956,4520,4839],0); -ELEMENTS[44101] = Fluid3D([4520,4567,4839,4159],0); -ELEMENTS[44102] = Fluid3D([4839,4520,4159,4777],0); -ELEMENTS[44103] = Fluid3D([4839,4520,4777,4875],0); -ELEMENTS[44104] = Fluid3D([4520,4567,4159,4032],0); -ELEMENTS[44105] = Fluid3D([4839,4520,4875,4956],0); -ELEMENTS[44106] = Fluid3D([4444,4567,4520,4032],0); -ELEMENTS[44107] = Fluid3D([12393,11534,11707,11979],0); -ELEMENTS[44108] = Fluid3D([11534,11707,11979,11339],0); -ELEMENTS[44109] = Fluid3D([11707,11979,11339,11716],0); -ELEMENTS[44110] = Fluid3D([11707,12393,11979,13024],0); -ELEMENTS[44111] = Fluid3D([11979,11339,11716,12159],0); -ELEMENTS[44112] = Fluid3D([11979,11339,12159,11379],0); -ELEMENTS[44113] = Fluid3D([17283,17320,17123,16898],0); -ELEMENTS[44114] = Fluid3D([17123,17283,16898,17168],0); -ELEMENTS[44115] = Fluid3D([17283,16898,17168,17136],0); -ELEMENTS[44116] = Fluid3D([6429,5902,5671,5845],0); -ELEMENTS[44117] = Fluid3D([9965,9190,9780,9773],0); -ELEMENTS[44118] = Fluid3D([7903,7343,7690,8043],0); -ELEMENTS[44119] = Fluid3D([7343,7690,8043,7355],0); -ELEMENTS[44120] = Fluid3D([8043,7343,7355,7903],0); -ELEMENTS[44121] = Fluid3D([7343,7690,7355,6696],0); -ELEMENTS[44122] = Fluid3D([7343,7690,6696,7192],0); -ELEMENTS[44123] = Fluid3D([7355,8043,7903,7567],0); -ELEMENTS[44124] = Fluid3D([16989,16710,16981,17209],0); -ELEMENTS[44125] = Fluid3D([16989,16710,17209,17062],0); -ELEMENTS[44126] = Fluid3D([16981,16989,17209,17508],0); -ELEMENTS[44127] = Fluid3D([15762,16176,15684,15964],0); -ELEMENTS[44128] = Fluid3D([16176,15684,15964,16362],0); -ELEMENTS[44129] = Fluid3D([15684,15762,15964,15494],0); -ELEMENTS[44130] = Fluid3D([15964,15684,15494,15706],0); -ELEMENTS[44131] = Fluid3D([15494,15964,15706,15904],0); -ELEMENTS[44132] = Fluid3D([15494,15964,15904,15762],0); -ELEMENTS[44133] = Fluid3D([15706,15494,15904,15169],0); -ELEMENTS[44134] = Fluid3D([18552,18557,18604,18447],0); -ELEMENTS[44135] = Fluid3D([18552,18557,18447,18506],0); -ELEMENTS[44136] = Fluid3D([14046,14434,14878,13730],0); -ELEMENTS[44137] = Fluid3D([14046,14434,13730,13473],0); -ELEMENTS[44138] = Fluid3D([13730,14046,13473,13069],0); -ELEMENTS[44139] = Fluid3D([13473,13730,13069,12546],0); -ELEMENTS[44140] = Fluid3D([13730,14046,13069,13366],0); -ELEMENTS[44141] = Fluid3D([13730,14046,13366,14012],0); -ELEMENTS[44142] = Fluid3D([13730,14046,14012,14878],0); -ELEMENTS[44143] = Fluid3D([2749,3114,2976,3064],0); -ELEMENTS[44144] = Fluid3D([17048,17102,16763,17392],0); -ELEMENTS[44145] = Fluid3D([11728,11350,12237,11656],0); -ELEMENTS[44146] = Fluid3D([4537,4527,4566,4896],0); -ELEMENTS[44147] = Fluid3D([4537,4527,4896,4979],0); -ELEMENTS[44148] = Fluid3D([4537,4527,4979,4681],0); -ELEMENTS[44149] = Fluid3D([4527,4979,4681,4935],0); -ELEMENTS[44150] = Fluid3D([4527,4896,4979,4935],0); -ELEMENTS[44151] = Fluid3D([8786,7910,8469,7545],0); -ELEMENTS[44152] = Fluid3D([6558,6518,5890,6165],0); -ELEMENTS[44153] = Fluid3D([2064,2116,1949,1919],0); -ELEMENTS[44154] = Fluid3D([17842,17530,17544,17447],0); -ELEMENTS[44155] = Fluid3D([18637,18644,18584,18578],0); -ELEMENTS[44156] = Fluid3D([18584,18637,18578,18643],0); -ELEMENTS[44157] = Fluid3D([18171,17970,18051,18142],0); -ELEMENTS[44158] = Fluid3D([3569,3353,3418,4030],0); -ELEMENTS[44159] = Fluid3D([10814,10018,9777,10484],0); -ELEMENTS[44160] = Fluid3D([4384,4778,4259,4231],0); -ELEMENTS[44161] = Fluid3D([18235,18252,18434,18472],0); -ELEMENTS[44162] = Fluid3D([6483,6181,5717,6390],0); -ELEMENTS[44163] = Fluid3D([14840,14260,14427,14211],0); -ELEMENTS[44164] = Fluid3D([14260,14427,14211,13535],0); -ELEMENTS[44165] = Fluid3D([14195,14850,14722,14523],0); -ELEMENTS[44166] = Fluid3D([14722,14195,14523,14613],0); -ELEMENTS[44167] = Fluid3D([14523,14722,14613,15054],0); -ELEMENTS[44168] = Fluid3D([14613,14523,15054,14749],0); -ELEMENTS[44169] = Fluid3D([14613,14523,14749,13691],0); -ELEMENTS[44170] = Fluid3D([14523,14722,15054,14850],0); -ELEMENTS[44171] = Fluid3D([13527,13510,14285,13374],0); -ELEMENTS[44172] = Fluid3D([11007,10358,10057,10181],0); -ELEMENTS[44173] = Fluid3D([4542,4683,4129,4811],0); -ELEMENTS[44174] = Fluid3D([16570,16288,16546,15918],0); -ELEMENTS[44175] = Fluid3D([15208,14837,14786,14873],0); -ELEMENTS[44176] = Fluid3D([14786,15208,14873,15498],0); -ELEMENTS[44177] = Fluid3D([5224,5125,4989,5526],0); -ELEMENTS[44178] = Fluid3D([5125,4989,5526,5282],0); -ELEMENTS[44179] = Fluid3D([5526,5125,5282,5729],0); -ELEMENTS[44180] = Fluid3D([5224,5125,5526,5729],0); -ELEMENTS[44181] = Fluid3D([5125,4989,5282,4741],0); -ELEMENTS[44182] = Fluid3D([2979,2880,2590,3128],0); -ELEMENTS[44183] = Fluid3D([15536,15622,15131,15403],0); -ELEMENTS[44184] = Fluid3D([12856,13676,13458,13843],0); -ELEMENTS[44185] = Fluid3D([12856,13676,13843,13867],0); -ELEMENTS[44186] = Fluid3D([12612,12591,12394,11924],0); -ELEMENTS[44187] = Fluid3D([12394,12612,11924,12062],0); -ELEMENTS[44188] = Fluid3D([12168,11405,12629,12093],0); -ELEMENTS[44189] = Fluid3D([3565,3904,4097,4296],0); -ELEMENTS[44190] = Fluid3D([3600,3374,3810,3402],0); -ELEMENTS[44191] = Fluid3D([15809,16143,15993,16290],0); -ELEMENTS[44192] = Fluid3D([7286,7920,7816,7700],0); -ELEMENTS[44193] = Fluid3D([7920,7816,7700,8508],0); -ELEMENTS[44194] = Fluid3D([7700,7920,8508,8390],0); -ELEMENTS[44195] = Fluid3D([7920,8508,8390,8906],0); -ELEMENTS[44196] = Fluid3D([7920,7816,8508,7919],0); -ELEMENTS[44197] = Fluid3D([7700,7920,8390,7679],0); -ELEMENTS[44198] = Fluid3D([7920,8508,8906,7919],0); -ELEMENTS[44199] = Fluid3D([13371,13194,13749,13952],0); -ELEMENTS[44200] = Fluid3D([12961,12496,13485,12943],0); -ELEMENTS[44201] = Fluid3D([8997,8506,7965,7849],0); -ELEMENTS[44202] = Fluid3D([3126,3102,3068,3504],0); -ELEMENTS[44203] = Fluid3D([17056,17304,17146,16723],0); -ELEMENTS[44204] = Fluid3D([7151,7387,6841,6475],0); -ELEMENTS[44205] = Fluid3D([6841,7151,6475,6272],0); -ELEMENTS[44206] = Fluid3D([7387,6841,6475,6839],0); -ELEMENTS[44207] = Fluid3D([11482,11502,11137,12117],0); -ELEMENTS[44208] = Fluid3D([11482,11502,12117,12456],0); -ELEMENTS[44209] = Fluid3D([11482,11502,12456,11845],0); -ELEMENTS[44210] = Fluid3D([12117,11482,12456,12435],0); -ELEMENTS[44211] = Fluid3D([11137,11482,12117,11133],0); -ELEMENTS[44212] = Fluid3D([10478,11237,10320,10021],0); -ELEMENTS[44213] = Fluid3D([11217,11166,10405,11861],0); -ELEMENTS[44214] = Fluid3D([14939,15407,15196,15247],0); -ELEMENTS[44215] = Fluid3D([12322,13173,13023,12527],0); -ELEMENTS[44216] = Fluid3D([10440,10187,9648,11120],0); -ELEMENTS[44217] = Fluid3D([4084,4058,4592,4304],0); -ELEMENTS[44218] = Fluid3D([4084,4058,4304,4047],0); -ELEMENTS[44219] = Fluid3D([4058,4592,4304,4356],0); -ELEMENTS[44220] = Fluid3D([4058,4304,4047,3822],0); -ELEMENTS[44221] = Fluid3D([4058,4304,3822,4356],0); -ELEMENTS[44222] = Fluid3D([4084,4058,4047,3540],0); -ELEMENTS[44223] = Fluid3D([5465,5120,5615,5048],0); -ELEMENTS[44224] = Fluid3D([5465,5120,5048,4907],0); -ELEMENTS[44225] = Fluid3D([5549,4935,5193,5123],0); -ELEMENTS[44226] = Fluid3D([4935,5193,5123,4573],0); -ELEMENTS[44227] = Fluid3D([5549,4935,5123,5384],0); -ELEMENTS[44228] = Fluid3D([10074,10154,11002,10516],0); -ELEMENTS[44229] = Fluid3D([10074,10154,10516,9859],0); -ELEMENTS[44230] = Fluid3D([9815,9499,10502,9753],0); -ELEMENTS[44231] = Fluid3D([10502,9815,9753,9372],0); -ELEMENTS[44232] = Fluid3D([9815,9499,9753,9210],0); -ELEMENTS[44233] = Fluid3D([9499,9753,9210,9265],0); -ELEMENTS[44234] = Fluid3D([9815,9499,9210,8492],0); -ELEMENTS[44235] = Fluid3D([9753,9815,9210,8689],0); -ELEMENTS[44236] = Fluid3D([9210,9753,8689,8330],0); -ELEMENTS[44237] = Fluid3D([8689,9210,8330,8492],0); -ELEMENTS[44238] = Fluid3D([9210,9499,9265,8455],0); -ELEMENTS[44239] = Fluid3D([9210,9499,8455,8492],0); -ELEMENTS[44240] = Fluid3D([8330,8689,8492,7658],0); -ELEMENTS[44241] = Fluid3D([8689,9210,8492,9815],0); -ELEMENTS[44242] = Fluid3D([8330,8689,7658,8404],0); -ELEMENTS[44243] = Fluid3D([10303,9413,9531,9785],0); -ELEMENTS[44244] = Fluid3D([9413,9531,9785,9260],0); -ELEMENTS[44245] = Fluid3D([13652,14505,14518,14144],0); -ELEMENTS[44246] = Fluid3D([14505,14518,14144,14368],0); -ELEMENTS[44247] = Fluid3D([14144,14505,14368,13848],0); -ELEMENTS[44248] = Fluid3D([14144,14505,13848,13652],0); -ELEMENTS[44249] = Fluid3D([14368,14144,13848,13333],0); -ELEMENTS[44250] = Fluid3D([14144,13848,13333,13652],0); -ELEMENTS[44251] = Fluid3D([14518,14144,14368,14156],0); -ELEMENTS[44252] = Fluid3D([9613,9211,9473,10298],0); -ELEMENTS[44253] = Fluid3D([9211,9473,10298,9581],0); -ELEMENTS[44254] = Fluid3D([16816,16605,16418,16251],0); -ELEMENTS[44255] = Fluid3D([12979,13704,13777,14373],0); -ELEMENTS[44256] = Fluid3D([11930,12695,12863,12599],0); -ELEMENTS[44257] = Fluid3D([14066,13760,14539,14529],0); -ELEMENTS[44258] = Fluid3D([5810,6286,5828,5864],0); -ELEMENTS[44259] = Fluid3D([4933,5495,5434,4713],0); -ELEMENTS[44260] = Fluid3D([14652,14150,14363,13795],0); -ELEMENTS[44261] = Fluid3D([13038,13306,13403,14155],0); -ELEMENTS[44262] = Fluid3D([13960,13141,13527,13374],0); -ELEMENTS[44263] = Fluid3D([15572,15687,15839,16219],0); -ELEMENTS[44264] = Fluid3D([18661,18639,18606,18619],0); -ELEMENTS[44265] = Fluid3D([18606,18661,18619,18645],0); -ELEMENTS[44266] = Fluid3D([18639,18606,18619,18577],0); -ELEMENTS[44267] = Fluid3D([15704,15788,15736,15259],0); -ELEMENTS[44268] = Fluid3D([15788,15736,15259,15304],0); -ELEMENTS[44269] = Fluid3D([15704,15788,15259,14915],0); -ELEMENTS[44270] = Fluid3D([4546,5244,4742,4964],0); -ELEMENTS[44271] = Fluid3D([4546,5244,4964,5466],0); -ELEMENTS[44272] = Fluid3D([5244,4964,5466,5106],0); -ELEMENTS[44273] = Fluid3D([10026,9572,9186,9956],0); -ELEMENTS[44274] = Fluid3D([9186,10026,9956,9935],0); -ELEMENTS[44275] = Fluid3D([9186,10026,9935,9584],0); -ELEMENTS[44276] = Fluid3D([10026,9956,9935,10553],0); -ELEMENTS[44277] = Fluid3D([10026,9956,10553,9572],0); -ELEMENTS[44278] = Fluid3D([9935,10026,10553,11057],0); -ELEMENTS[44279] = Fluid3D([10026,9935,9584,10372],0); -ELEMENTS[44280] = Fluid3D([17131,16759,16593,16676],0); -ELEMENTS[44281] = Fluid3D([6219,5623,5743,5726],0); -ELEMENTS[44282] = Fluid3D([17223,17597,17541,17390],0); -ELEMENTS[44283] = Fluid3D([9360,8464,9395,9230],0); -ELEMENTS[44284] = Fluid3D([18228,17964,18202,18074],0); -ELEMENTS[44285] = Fluid3D([3861,3479,3548,3250],0); -ELEMENTS[44286] = Fluid3D([13408,13430,13286,14217],0); -ELEMENTS[44287] = Fluid3D([5014,5023,5448,5417],0); -ELEMENTS[44288] = Fluid3D([5359,4954,4780,5173],0); -ELEMENTS[44289] = Fluid3D([2613,2581,2870,2512],0); -ELEMENTS[44290] = Fluid3D([2870,2613,2512,2740],0); -ELEMENTS[44291] = Fluid3D([2613,2512,2740,2677],0); -ELEMENTS[44292] = Fluid3D([10686,11554,11232,11038],0); -ELEMENTS[44293] = Fluid3D([3056,2871,2789,2504],0); -ELEMENTS[44294] = Fluid3D([12982,12793,12976,13279],0); -ELEMENTS[44295] = Fluid3D([18179,18123,17944,18236],0); -ELEMENTS[44296] = Fluid3D([18179,18123,18236,18367],0); -ELEMENTS[44297] = Fluid3D([18123,18236,18367,18217],0); -ELEMENTS[44298] = Fluid3D([18123,18236,18217,18064],0); -ELEMENTS[44299] = Fluid3D([18123,18236,18064,17908],0); -ELEMENTS[44300] = Fluid3D([18123,18236,17908,17944],0); -ELEMENTS[44301] = Fluid3D([8309,8351,9088,8079],0); -ELEMENTS[44302] = Fluid3D([8309,8351,8079,7432],0); -ELEMENTS[44303] = Fluid3D([8351,9088,8079,8645],0); -ELEMENTS[44304] = Fluid3D([8079,8351,8645,7639],0); -ELEMENTS[44305] = Fluid3D([8079,8351,7639,7432],0); -ELEMENTS[44306] = Fluid3D([3574,3307,3907,3403],0); -ELEMENTS[44307] = Fluid3D([11656,12469,11631,11548],0); -ELEMENTS[44308] = Fluid3D([11631,11656,11548,10788],0); -ELEMENTS[44309] = Fluid3D([11548,11631,10788,12082],0); -ELEMENTS[44310] = Fluid3D([11548,11631,12082,12894],0); -ELEMENTS[44311] = Fluid3D([12469,11631,11548,12894],0); -ELEMENTS[44312] = Fluid3D([8083,7544,7275,7362],0); -ELEMENTS[44313] = Fluid3D([15055,15548,15326,15037],0); -ELEMENTS[44314] = Fluid3D([8712,8197,7641,8483],0); -ELEMENTS[44315] = Fluid3D([17807,17762,17758,17985],0); -ELEMENTS[44316] = Fluid3D([17762,17758,17985,17954],0); -ELEMENTS[44317] = Fluid3D([17758,17807,17985,18027],0); -ELEMENTS[44318] = Fluid3D([6079,6483,5717,6097],0); -ELEMENTS[44319] = Fluid3D([13182,13813,13091,13905],0); -ELEMENTS[44320] = Fluid3D([5823,6144,5444,6075],0); -ELEMENTS[44321] = Fluid3D([5823,6144,6075,6489],0); -ELEMENTS[44322] = Fluid3D([15449,16091,15895,16293],0); -ELEMENTS[44323] = Fluid3D([2404,2289,2222,2152],0); -ELEMENTS[44324] = Fluid3D([2222,2404,2152,2326],0); -ELEMENTS[44325] = Fluid3D([17907,18121,17860,17997],0); -ELEMENTS[44326] = Fluid3D([17860,17907,17997,17763],0); -ELEMENTS[44327] = Fluid3D([18121,17860,17997,18190],0); -ELEMENTS[44328] = Fluid3D([17997,17860,17763,17866],0); -ELEMENTS[44329] = Fluid3D([17860,17997,18190,18086],0); -ELEMENTS[44330] = Fluid3D([17997,17860,17866,18086],0); -ELEMENTS[44331] = Fluid3D([11737,10886,11762,11481],0); -ELEMENTS[44332] = Fluid3D([8270,9132,9259,8764],0); -ELEMENTS[44333] = Fluid3D([11805,11182,11775,11900],0); -ELEMENTS[44334] = Fluid3D([10765,11605,11928,11775],0); -ELEMENTS[44335] = Fluid3D([12829,12997,13516,14021],0); -ELEMENTS[44336] = Fluid3D([12409,12779,13686,13399],0); -ELEMENTS[44337] = Fluid3D([7257,7768,8147,8027],0); -ELEMENTS[44338] = Fluid3D([3374,3410,3810,3402],0); -ELEMENTS[44339] = Fluid3D([8124,8399,7378,8228],0); -ELEMENTS[44340] = Fluid3D([15224,15751,15823,15302],0); -ELEMENTS[44341] = Fluid3D([6061,5520,5817,5606],0); -ELEMENTS[44342] = Fluid3D([4708,5076,5124,5277],0); -ELEMENTS[44343] = Fluid3D([4460,5040,4565,4274],0); -ELEMENTS[44344] = Fluid3D([4565,4460,4274,4054],0); -ELEMENTS[44345] = Fluid3D([4565,4460,4054,4353],0); -ELEMENTS[44346] = Fluid3D([4460,4274,4054,3815],0); -ELEMENTS[44347] = Fluid3D([8655,9770,9020,9266],0); -ELEMENTS[44348] = Fluid3D([9428,9401,10252,9668],0); -ELEMENTS[44349] = Fluid3D([15516,15835,15293,15952],0); -ELEMENTS[44350] = Fluid3D([15835,15293,15952,15692],0); -ELEMENTS[44351] = Fluid3D([5306,4926,5572,4756],0); -ELEMENTS[44352] = Fluid3D([15692,15727,16197,15835],0); -ELEMENTS[44353] = Fluid3D([10874,11654,11948,10851],0); -ELEMENTS[44354] = Fluid3D([10244,10841,11268,10914],0); -ELEMENTS[44355] = Fluid3D([10244,10841,10914,10364],0); -ELEMENTS[44356] = Fluid3D([12826,11948,12253,12840],0); -ELEMENTS[44357] = Fluid3D([11948,12253,12840,11601],0); -ELEMENTS[44358] = Fluid3D([12253,12826,12840,13243],0); -ELEMENTS[44359] = Fluid3D([12840,12253,13243,12928],0); -ELEMENTS[44360] = Fluid3D([12840,12253,12928,11601],0); -ELEMENTS[44361] = Fluid3D([12253,13243,12928,12303],0); -ELEMENTS[44362] = Fluid3D([13243,12840,12928,13959],0); -ELEMENTS[44363] = Fluid3D([12253,12826,13243,12754],0); -ELEMENTS[44364] = Fluid3D([12826,12840,13243,13766],0); -ELEMENTS[44365] = Fluid3D([12840,13243,13766,13959],0); -ELEMENTS[44366] = Fluid3D([12826,12840,13766,12595],0); -ELEMENTS[44367] = Fluid3D([12840,13766,12595,12944],0); -ELEMENTS[44368] = Fluid3D([12840,13766,12944,13959],0); -ELEMENTS[44369] = Fluid3D([12595,12840,12944,11932],0); -ELEMENTS[44370] = Fluid3D([13766,12595,12944,12767],0); -ELEMENTS[44371] = Fluid3D([12826,12840,12595,11948],0); -ELEMENTS[44372] = Fluid3D([12840,12595,11948,11932],0); -ELEMENTS[44373] = Fluid3D([12595,11948,11932,12425],0); -ELEMENTS[44374] = Fluid3D([12595,11948,12425,12826],0); -ELEMENTS[44375] = Fluid3D([11932,12595,12425,12767],0); -ELEMENTS[44376] = Fluid3D([12595,12425,12767,13404],0); -ELEMENTS[44377] = Fluid3D([12595,12425,13404,12826],0); -ELEMENTS[44378] = Fluid3D([12944,12595,11932,12767],0); -ELEMENTS[44379] = Fluid3D([18125,18052,18144,18303],0); -ELEMENTS[44380] = Fluid3D([18052,18144,18303,18247],0); -ELEMENTS[44381] = Fluid3D([18144,18125,18303,18351],0); -ELEMENTS[44382] = Fluid3D([12348,12185,11604,12711],0); -ELEMENTS[44383] = Fluid3D([2899,2854,2841,2517],0); -ELEMENTS[44384] = Fluid3D([16748,16618,16264,16189],0); -ELEMENTS[44385] = Fluid3D([5105,5748,5197,5106],0); -ELEMENTS[44386] = Fluid3D([10741,11205,11136,11050],0); -ELEMENTS[44387] = Fluid3D([18366,18202,18135,18286],0); -ELEMENTS[44388] = Fluid3D([12490,12133,12976,11944],0); -ELEMENTS[44389] = Fluid3D([15462,16011,15687,16040],0); -ELEMENTS[44390] = Fluid3D([12907,12643,13322,13593],0); -ELEMENTS[44391] = Fluid3D([17993,18182,18010,18222],0); -ELEMENTS[44392] = Fluid3D([18182,18010,18222,18255],0); -ELEMENTS[44393] = Fluid3D([17993,18182,18222,18324],0); -ELEMENTS[44394] = Fluid3D([4561,4119,4184,4375],0); -ELEMENTS[44395] = Fluid3D([7391,6977,7215,6742],0); -ELEMENTS[44396] = Fluid3D([12943,12085,12961,12496],0); -ELEMENTS[44397] = Fluid3D([12855,12544,13245,12454],0); -ELEMENTS[44398] = Fluid3D([13245,12855,12454,12583],0); -ELEMENTS[44399] = Fluid3D([12454,13245,12583,12985],0); -ELEMENTS[44400] = Fluid3D([12454,13245,12985,12544],0); -ELEMENTS[44401] = Fluid3D([12583,12454,12985,12501],0); -ELEMENTS[44402] = Fluid3D([12583,12454,12501,11816],0); -ELEMENTS[44403] = Fluid3D([13556,14114,14198,13888],0); -ELEMENTS[44404] = Fluid3D([13556,14114,13888,13784],0); -ELEMENTS[44405] = Fluid3D([16695,16290,16745,16917],0); -ELEMENTS[44406] = Fluid3D([17022,17083,17271,16805],0); -ELEMENTS[44407] = Fluid3D([4870,4585,4451,4610],0); -ELEMENTS[44408] = Fluid3D([3289,3233,3014,3340],0); -ELEMENTS[44409] = Fluid3D([3289,3233,3340,3692],0); -ELEMENTS[44410] = Fluid3D([3014,3289,3340,3452],0); -ELEMENTS[44411] = Fluid3D([3014,3289,3452,3127],0); -ELEMENTS[44412] = Fluid3D([3289,3340,3452,3813],0); -ELEMENTS[44413] = Fluid3D([3289,3452,3127,3592],0); -ELEMENTS[44414] = Fluid3D([15064,15653,15021,15145],0); -ELEMENTS[44415] = Fluid3D([6182,6553,6669,5752],0); -ELEMENTS[44416] = Fluid3D([9532,9476,9504,8500],0); -ELEMENTS[44417] = Fluid3D([7141,6853,6281,6725],0); -ELEMENTS[44418] = Fluid3D([6390,6978,6483,6181],0); -ELEMENTS[44419] = Fluid3D([7238,7328,7477,8142],0); -ELEMENTS[44420] = Fluid3D([14743,15011,15405,15632],0); -ELEMENTS[44421] = Fluid3D([4646,4853,5084,4471],0); -ELEMENTS[44422] = Fluid3D([5084,4646,4471,4928],0); -ELEMENTS[44423] = Fluid3D([13651,13184,14232,13275],0); -ELEMENTS[44424] = Fluid3D([14698,14502,14982,14068],0); -ELEMENTS[44425] = Fluid3D([14698,14502,14068,14591],0); -ELEMENTS[44426] = Fluid3D([2448,2477,2357,2727],0); -ELEMENTS[44427] = Fluid3D([7337,7976,8309,7613],0); -ELEMENTS[44428] = Fluid3D([2866,3188,3195,2836],0); -ELEMENTS[44429] = Fluid3D([15981,16286,16285,15858],0); -ELEMENTS[44430] = Fluid3D([13517,13016,13794,13146],0); -ELEMENTS[44431] = Fluid3D([5295,4879,5251,5022],0); -ELEMENTS[44432] = Fluid3D([15954,16286,16146,15858],0); -ELEMENTS[44433] = Fluid3D([4939,5486,5408,5397],0); -ELEMENTS[44434] = Fluid3D([17340,17322,17744,17370],0); -ELEMENTS[44435] = Fluid3D([3024,3305,3438,3375],0); -ELEMENTS[44436] = Fluid3D([3305,3438,3375,3882],0); -ELEMENTS[44437] = Fluid3D([3438,3024,3375,3075],0); -ELEMENTS[44438] = Fluid3D([17965,18093,17789,18090],0); -ELEMENTS[44439] = Fluid3D([8960,9027,8211,8067],0); -ELEMENTS[44440] = Fluid3D([14216,13546,13765,13274],0); -ELEMENTS[44441] = Fluid3D([17990,17897,18149,17863],0); -ELEMENTS[44442] = Fluid3D([13410,13535,13172,12522],0); -ELEMENTS[44443] = Fluid3D([13410,13535,12522,12384],0); -ELEMENTS[44444] = Fluid3D([5873,5495,5670,5320],0); -ELEMENTS[44445] = Fluid3D([5873,5495,5320,5946],0); -ELEMENTS[44446] = Fluid3D([8412,7472,7610,8006],0); -ELEMENTS[44447] = Fluid3D([7472,7610,8006,7250],0); -ELEMENTS[44448] = Fluid3D([12393,11815,12260,13075],0); -ELEMENTS[44449] = Fluid3D([2859,2825,2846,3163],0); -ELEMENTS[44450] = Fluid3D([13798,13969,13818,13085],0); -ELEMENTS[44451] = Fluid3D([5415,5165,5197,6000],0); -ELEMENTS[44452] = Fluid3D([13007,13052,13718,13666],0); -ELEMENTS[44453] = Fluid3D([13007,13052,13666,13053],0); -ELEMENTS[44454] = Fluid3D([13666,13007,13053,13428],0); -ELEMENTS[44455] = Fluid3D([13052,13666,13053,13691],0); -ELEMENTS[44456] = Fluid3D([13718,13007,13666,14259],0); -ELEMENTS[44457] = Fluid3D([13666,13007,13428,14259],0); -ELEMENTS[44458] = Fluid3D([13053,13666,13428,14141],0); -ELEMENTS[44459] = Fluid3D([13053,13666,14141,13691],0); -ELEMENTS[44460] = Fluid3D([13428,13666,14259,14141],0); -ELEMENTS[44461] = Fluid3D([13666,14259,14141,14469],0); -ELEMENTS[44462] = Fluid3D([16982,16654,16857,16717],0); -ELEMENTS[44463] = Fluid3D([17117,17455,17300,17158],0); -ELEMENTS[44464] = Fluid3D([17117,17455,17158,17285],0); -ELEMENTS[44465] = Fluid3D([12732,13354,12950,13334],0); -ELEMENTS[44466] = Fluid3D([18220,18057,18229,18249],0); -ELEMENTS[44467] = Fluid3D([4474,4343,4531,4679],0); -ELEMENTS[44468] = Fluid3D([9667,9157,9352,10078],0); -ELEMENTS[44469] = Fluid3D([9352,9667,10078,10351],0); -ELEMENTS[44470] = Fluid3D([9667,10078,10351,9918],0); -ELEMENTS[44471] = Fluid3D([9667,9157,10078,9918],0); -ELEMENTS[44472] = Fluid3D([8297,7411,7855,7661],0); -ELEMENTS[44473] = Fluid3D([14423,14960,14481,13842],0); -ELEMENTS[44474] = Fluid3D([7044,6420,6274,6293],0); -ELEMENTS[44475] = Fluid3D([6420,6274,6293,5702],0); -ELEMENTS[44476] = Fluid3D([6274,7044,6293,6922],0); -ELEMENTS[44477] = Fluid3D([6420,6274,5702,5935],0); -ELEMENTS[44478] = Fluid3D([6274,5702,5935,6065],0); -ELEMENTS[44479] = Fluid3D([5935,6274,6065,6238],0); -ELEMENTS[44480] = Fluid3D([6274,6293,5702,6065],0); -ELEMENTS[44481] = Fluid3D([6274,6293,6065,6922],0); -ELEMENTS[44482] = Fluid3D([3756,4057,4105,3553],0); -ELEMENTS[44483] = Fluid3D([4436,4755,4830,4384],0); -ELEMENTS[44484] = Fluid3D([4436,4755,4384,4010],0); -ELEMENTS[44485] = Fluid3D([4384,4436,4010,4352],0); -ELEMENTS[44486] = Fluid3D([9365,9635,8605,8597],0); -ELEMENTS[44487] = Fluid3D([8294,8257,8299,7344],0); -ELEMENTS[44488] = Fluid3D([9673,10229,10664,10065],0); -ELEMENTS[44489] = Fluid3D([9673,10229,10065,9640],0); -ELEMENTS[44490] = Fluid3D([10229,10065,9640,10873],0); -ELEMENTS[44491] = Fluid3D([10099,9335,9313,9858],0); -ELEMENTS[44492] = Fluid3D([13281,13530,13870,13762],0); -ELEMENTS[44493] = Fluid3D([10104,9677,10493,10290],0); -ELEMENTS[44494] = Fluid3D([4343,4295,4429,4797],0); -ELEMENTS[44495] = Fluid3D([7428,6793,7507,7519],0); -ELEMENTS[44496] = Fluid3D([17902,17885,17751,17989],0); -ELEMENTS[44497] = Fluid3D([16197,16335,15692,16318],0); -ELEMENTS[44498] = Fluid3D([16197,16335,16318,16779],0); -ELEMENTS[44499] = Fluid3D([8740,8792,9787,8844],0); -ELEMENTS[44500] = Fluid3D([4070,3960,4378,4300],0); -ELEMENTS[44501] = Fluid3D([5225,5969,5556,5419],0); -ELEMENTS[44502] = Fluid3D([13359,13399,12770,12149],0); -ELEMENTS[44503] = Fluid3D([3875,4361,4526,4087],0); -ELEMENTS[44504] = Fluid3D([3875,4361,4087,4350],0); -ELEMENTS[44505] = Fluid3D([4361,4526,4087,4564],0); -ELEMENTS[44506] = Fluid3D([4361,4526,4564,4894],0); -ELEMENTS[44507] = Fluid3D([4361,4526,4894,5206],0); -ELEMENTS[44508] = Fluid3D([8298,8693,8184,9141],0); -ELEMENTS[44509] = Fluid3D([11147,11664,11523,10570],0); -ELEMENTS[44510] = Fluid3D([11680,12107,12074,10814],0); -ELEMENTS[44511] = Fluid3D([12335,12247,12639,13252],0); -ELEMENTS[44512] = Fluid3D([7188,6936,6978,7776],0); -ELEMENTS[44513] = Fluid3D([17875,18067,18200,18276],0); -ELEMENTS[44514] = Fluid3D([15707,15109,15167,15485],0); -ELEMENTS[44515] = Fluid3D([15707,15109,15485,15506],0); -ELEMENTS[44516] = Fluid3D([18271,18088,18097,18143],0); -ELEMENTS[44517] = Fluid3D([13563,13035,14004,13868],0); -ELEMENTS[44518] = Fluid3D([14004,13563,13868,14397],0); -ELEMENTS[44519] = Fluid3D([13563,13035,13868,12721],0); -ELEMENTS[44520] = Fluid3D([14634,14479,15170,14589],0); -ELEMENTS[44521] = Fluid3D([9145,9378,8402,8498],0); -ELEMENTS[44522] = Fluid3D([1812,1933,1874,2047],0); -ELEMENTS[44523] = Fluid3D([1933,1874,2047,2025],0); -ELEMENTS[44524] = Fluid3D([15500,15793,15938,15355],0); -ELEMENTS[44525] = Fluid3D([4074,3798,3816,4330],0); -ELEMENTS[44526] = Fluid3D([11238,11104,10322,11284],0); -ELEMENTS[44527] = Fluid3D([18470,18452,18565,18502],0); -ELEMENTS[44528] = Fluid3D([18565,18470,18502,18589],0); -ELEMENTS[44529] = Fluid3D([18452,18565,18502,18553],0); -ELEMENTS[44530] = Fluid3D([18565,18502,18553,18624],0); -ELEMENTS[44531] = Fluid3D([18502,18452,18553,18412],0); -ELEMENTS[44532] = Fluid3D([18452,18565,18553,18595],0); -ELEMENTS[44533] = Fluid3D([16211,16687,16289,16804],0); -ELEMENTS[44534] = Fluid3D([4902,4730,5423,5278],0); -ELEMENTS[44535] = Fluid3D([5751,5113,5186,5658],0); -ELEMENTS[44536] = Fluid3D([9434,9091,8575,9648],0); -ELEMENTS[44537] = Fluid3D([9395,9367,10077,10031],0); -ELEMENTS[44538] = Fluid3D([4971,4921,4509,4630],0); -ELEMENTS[44539] = Fluid3D([3362,3613,3198,3437],0); -ELEMENTS[44540] = Fluid3D([11160,11419,11775,12544],0); -ELEMENTS[44541] = Fluid3D([3229,3295,2892,3184],0); -ELEMENTS[44542] = Fluid3D([3229,3295,3184,3640],0); -ELEMENTS[44543] = Fluid3D([2892,3229,3184,2845],0); -ELEMENTS[44544] = Fluid3D([3553,3879,4057,4105],0); -ELEMENTS[44545] = Fluid3D([16987,16714,17193,17272],0); -ELEMENTS[44546] = Fluid3D([11591,11336,10596,11118],0); -ELEMENTS[44547] = Fluid3D([12789,12788,12495,13405],0); -ELEMENTS[44548] = Fluid3D([12788,12495,13405,13400],0); -ELEMENTS[44549] = Fluid3D([13405,12788,13400,14057],0); -ELEMENTS[44550] = Fluid3D([12495,12789,13405,13006],0); -ELEMENTS[44551] = Fluid3D([13405,12495,13006,12973],0); -ELEMENTS[44552] = Fluid3D([12789,13405,13006,13255],0); -ELEMENTS[44553] = Fluid3D([13006,12789,13255,12315],0); -ELEMENTS[44554] = Fluid3D([12789,13405,13255,13549],0); -ELEMENTS[44555] = Fluid3D([13255,12789,13549,12946],0); -ELEMENTS[44556] = Fluid3D([13405,13006,13255,13821],0); -ELEMENTS[44557] = Fluid3D([13006,13255,13821,13131],0); -ELEMENTS[44558] = Fluid3D([13821,13006,13131,13405],0); -ELEMENTS[44559] = Fluid3D([13255,13405,13821,14239],0); -ELEMENTS[44560] = Fluid3D([13006,13255,13131,12315],0); -ELEMENTS[44561] = Fluid3D([13131,13006,12315,12160],0); -ELEMENTS[44562] = Fluid3D([12789,13405,13549,12788],0); -ELEMENTS[44563] = Fluid3D([13405,13255,13549,14239],0); -ELEMENTS[44564] = Fluid3D([12495,12789,13006,12315],0); -ELEMENTS[44565] = Fluid3D([13255,13549,14239,13834],0); -ELEMENTS[44566] = Fluid3D([13549,14239,13834,13781],0); -ELEMENTS[44567] = Fluid3D([13834,13549,13781,12872],0); -ELEMENTS[44568] = Fluid3D([13549,14239,13781,14057],0); -ELEMENTS[44569] = Fluid3D([13549,13781,12872,12788],0); -ELEMENTS[44570] = Fluid3D([14239,13834,13781,14669],0); -ELEMENTS[44571] = Fluid3D([13834,13781,14669,14282],0); -ELEMENTS[44572] = Fluid3D([13255,13549,13834,12946],0); -ELEMENTS[44573] = Fluid3D([13549,13834,12946,12872],0); -ELEMENTS[44574] = Fluid3D([13255,12789,12946,12400],0); -ELEMENTS[44575] = Fluid3D([13255,12789,12400,12315],0); -ELEMENTS[44576] = Fluid3D([6228,6894,6173,6726],0); -ELEMENTS[44577] = Fluid3D([7867,7873,7926,7353],0); -ELEMENTS[44578] = Fluid3D([10171,9607,10426,10391],0); -ELEMENTS[44579] = Fluid3D([8414,8912,9509,9415],0); -ELEMENTS[44580] = Fluid3D([18315,18436,18244,18443],0); -ELEMENTS[44581] = Fluid3D([18588,18537,18626,18572],0); -ELEMENTS[44582] = Fluid3D([18588,18537,18572,18444],0); -ELEMENTS[44583] = Fluid3D([17103,17061,16873,17364],0); -ELEMENTS[44584] = Fluid3D([8890,8483,8965,9223],0); -ELEMENTS[44585] = Fluid3D([8890,8483,9223,8708],0); -ELEMENTS[44586] = Fluid3D([10228,10028,10087,9029],0); -ELEMENTS[44587] = Fluid3D([10282,10858,10747,9614],0); -ELEMENTS[44588] = Fluid3D([5532,5488,6031,6130],0); -ELEMENTS[44589] = Fluid3D([18164,18083,18082,18331],0); -ELEMENTS[44590] = Fluid3D([18083,18082,18331,18260],0); -ELEMENTS[44591] = Fluid3D([18233,18016,18131,18191],0); -ELEMENTS[44592] = Fluid3D([2774,2794,2946,3223],0); -ELEMENTS[44593] = Fluid3D([12019,12305,12194,13204],0); -ELEMENTS[44594] = Fluid3D([5483,5637,5898,5087],0); -ELEMENTS[44595] = Fluid3D([5898,5483,5087,5350],0); -ELEMENTS[44596] = Fluid3D([5483,5087,5350,4710],0); -ELEMENTS[44597] = Fluid3D([16545,16516,15994,16451],0); -ELEMENTS[44598] = Fluid3D([16545,16516,16451,17009],0); -ELEMENTS[44599] = Fluid3D([16451,16545,17009,16922],0); -ELEMENTS[44600] = Fluid3D([16545,17009,16922,16644],0); -ELEMENTS[44601] = Fluid3D([10187,9434,9648,9091],0); -ELEMENTS[44602] = Fluid3D([12899,13713,13743,13335],0); -ELEMENTS[44603] = Fluid3D([12899,13713,13335,13171],0); -ELEMENTS[44604] = Fluid3D([10743,11088,10098,10373],0); -ELEMENTS[44605] = Fluid3D([15506,16130,15962,15707],0); -ELEMENTS[44606] = Fluid3D([14685,15108,14697,14390],0); -ELEMENTS[44607] = Fluid3D([8424,7605,8134,8500],0); -ELEMENTS[44608] = Fluid3D([8728,8474,9375,8755],0); -ELEMENTS[44609] = Fluid3D([16016,15570,16371,16095],0); -ELEMENTS[44610] = Fluid3D([16314,16343,15886,16244],0); -ELEMENTS[44611] = Fluid3D([14234,13759,13741,14603],0); -ELEMENTS[44612] = Fluid3D([14234,13759,14603,14707],0); -ELEMENTS[44613] = Fluid3D([11472,11804,12197,11031],0); -ELEMENTS[44614] = Fluid3D([5329,5229,4798,4834],0); -ELEMENTS[44615] = Fluid3D([5229,4798,4834,4793],0); -ELEMENTS[44616] = Fluid3D([15284,15003,15245,15916],0); -ELEMENTS[44617] = Fluid3D([6749,7556,6659,7164],0); -ELEMENTS[44618] = Fluid3D([4406,4473,4849,4469],0); -ELEMENTS[44619] = Fluid3D([10466,11429,11121,10472],0); -ELEMENTS[44620] = Fluid3D([8685,8511,8683,7898],0); -ELEMENTS[44621] = Fluid3D([8685,8511,7898,8552],0); -ELEMENTS[44622] = Fluid3D([9754,9382,10475,9687],0); -ELEMENTS[44623] = Fluid3D([12464,11958,12087,11275],0); -ELEMENTS[44624] = Fluid3D([11958,12087,11275,11588],0); -ELEMENTS[44625] = Fluid3D([11275,11958,11588,10833],0); -ELEMENTS[44626] = Fluid3D([11588,11275,10833,10465],0); -ELEMENTS[44627] = Fluid3D([10833,11588,10465,10961],0); -ELEMENTS[44628] = Fluid3D([10465,10833,10961,10336],0); -ELEMENTS[44629] = Fluid3D([10833,10961,10336,11520],0); -ELEMENTS[44630] = Fluid3D([10833,11588,10961,11924],0); -ELEMENTS[44631] = Fluid3D([10833,11588,11924,11958],0); -ELEMENTS[44632] = Fluid3D([11588,11924,11958,12087],0); -ELEMENTS[44633] = Fluid3D([10465,10833,10336,9710],0); -ELEMENTS[44634] = Fluid3D([10961,10465,10336,10502],0); -ELEMENTS[44635] = Fluid3D([10336,10961,10502,10784],0); -ELEMENTS[44636] = Fluid3D([10336,10961,10784,11509],0); -ELEMENTS[44637] = Fluid3D([11588,10961,11924,11897],0); -ELEMENTS[44638] = Fluid3D([11588,11924,12087,11897],0); -ELEMENTS[44639] = Fluid3D([11275,10833,10465,9710],0); -ELEMENTS[44640] = Fluid3D([10961,10502,10784,11897],0); -ELEMENTS[44641] = Fluid3D([18041,18244,18207,18360],0); -ELEMENTS[44642] = Fluid3D([13470,12982,13685,13279],0); -ELEMENTS[44643] = Fluid3D([16112,16025,16377,16597],0); -ELEMENTS[44644] = Fluid3D([16377,16112,16597,16740],0); -ELEMENTS[44645] = Fluid3D([6996,7178,6651,6646],0); -ELEMENTS[44646] = Fluid3D([15893,15746,16099,16607],0); -ELEMENTS[44647] = Fluid3D([15498,15779,16244,15345],0); -ELEMENTS[44648] = Fluid3D([4601,4742,4204,4182],0); -ELEMENTS[44649] = Fluid3D([12133,12410,12976,13279],0); -ELEMENTS[44650] = Fluid3D([12525,13234,13016,13794],0); -ELEMENTS[44651] = Fluid3D([4282,4584,4655,4768],0); -ELEMENTS[44652] = Fluid3D([5350,5360,5756,6225],0); -ELEMENTS[44653] = Fluid3D([17151,16985,17138,16705],0); -ELEMENTS[44654] = Fluid3D([9057,9103,9835,9252],0); -ELEMENTS[44655] = Fluid3D([14545,14917,15140,15297],0); -ELEMENTS[44656] = Fluid3D([5277,5828,5398,5076],0); -ELEMENTS[44657] = Fluid3D([14319,14043,14807,14327],0); -ELEMENTS[44658] = Fluid3D([14319,14043,14327,13619],0); -ELEMENTS[44659] = Fluid3D([15818,16134,16161,15535],0); -ELEMENTS[44660] = Fluid3D([14014,14300,14445,15046],0); -ELEMENTS[44661] = Fluid3D([11206,11398,12323,11770],0); -ELEMENTS[44662] = Fluid3D([13533,12873,12605,13147],0); -ELEMENTS[44663] = Fluid3D([8515,8341,9252,9103],0); -ELEMENTS[44664] = Fluid3D([10094,9246,9472,9954],0); -ELEMENTS[44665] = Fluid3D([4130,4183,4101,4684],0); -ELEMENTS[44666] = Fluid3D([17495,17677,17473,17254],0); -ELEMENTS[44667] = Fluid3D([14864,14541,14229,15073],0); -ELEMENTS[44668] = Fluid3D([14864,14541,15073,15463],0); -ELEMENTS[44669] = Fluid3D([15933,15821,15930,16486],0); -ELEMENTS[44670] = Fluid3D([5075,4853,4772,5218],0); -ELEMENTS[44671] = Fluid3D([14211,14112,14427,15190],0); -ELEMENTS[44672] = Fluid3D([11855,12705,12492,13125],0); -ELEMENTS[44673] = Fluid3D([16355,16136,16496,15749],0); -ELEMENTS[44674] = Fluid3D([16146,16286,15981,15796],0); -ELEMENTS[44675] = Fluid3D([16146,16286,15796,15858],0); -ELEMENTS[44676] = Fluid3D([16286,15981,15796,15858],0); -ELEMENTS[44677] = Fluid3D([15981,16146,15796,16235],0); -ELEMENTS[44678] = Fluid3D([15981,15796,15858,15438],0); -ELEMENTS[44679] = Fluid3D([15981,15796,15438,15754],0); -ELEMENTS[44680] = Fluid3D([15981,15796,15754,16235],0); -ELEMENTS[44681] = Fluid3D([15796,15858,15438,15954],0); -ELEMENTS[44682] = Fluid3D([15754,15981,16235,15760],0); -ELEMENTS[44683] = Fluid3D([15796,15438,15754,15649],0); -ELEMENTS[44684] = Fluid3D([15754,15796,15649,16235],0); -ELEMENTS[44685] = Fluid3D([15649,15754,16235,15876],0); -ELEMENTS[44686] = Fluid3D([15438,15981,15754,15341],0); -ELEMENTS[44687] = Fluid3D([15858,15981,15438,15616],0); -ELEMENTS[44688] = Fluid3D([15438,15858,15616,15033],0); -ELEMENTS[44689] = Fluid3D([15438,15858,15033,15757],0); -ELEMENTS[44690] = Fluid3D([17977,18133,18261,18061],0); -ELEMENTS[44691] = Fluid3D([17977,18133,18061,17895],0); -ELEMENTS[44692] = Fluid3D([18061,17977,17895,17715],0); -ELEMENTS[44693] = Fluid3D([18061,17977,17715,18113],0); -ELEMENTS[44694] = Fluid3D([18061,17977,18113,18261],0); -ELEMENTS[44695] = Fluid3D([18113,18061,18261,18285],0); -ELEMENTS[44696] = Fluid3D([18113,18061,18285,18149],0); -ELEMENTS[44697] = Fluid3D([18113,18061,18149,17895],0); -ELEMENTS[44698] = Fluid3D([18113,18061,17895,17715],0); -ELEMENTS[44699] = Fluid3D([17827,17419,17636,17715],0); -ELEMENTS[44700] = Fluid3D([3000,3344,3358,3104],0); -ELEMENTS[44701] = Fluid3D([3344,3358,3104,3476],0); -ELEMENTS[44702] = Fluid3D([3000,3344,3104,2789],0); -ELEMENTS[44703] = Fluid3D([6822,6949,7348,7726],0); -ELEMENTS[44704] = Fluid3D([6949,7348,7726,7213],0); -ELEMENTS[44705] = Fluid3D([14008,13895,13363,13474],0); -ELEMENTS[44706] = Fluid3D([2577,2279,2480,2387],0); -ELEMENTS[44707] = Fluid3D([2480,2577,2387,2672],0); -ELEMENTS[44708] = Fluid3D([2480,2577,2672,2932],0); -ELEMENTS[44709] = Fluid3D([2387,2480,2672,2273],0); -ELEMENTS[44710] = Fluid3D([2577,2387,2672,2423],0); -ELEMENTS[44711] = Fluid3D([2387,2672,2423,2273],0); -ELEMENTS[44712] = Fluid3D([2423,2387,2273,2201],0); -ELEMENTS[44713] = Fluid3D([2423,2387,2201,2344],0); -ELEMENTS[44714] = Fluid3D([2423,2387,2344,2609],0); -ELEMENTS[44715] = Fluid3D([2387,2273,2201,2480],0); -ELEMENTS[44716] = Fluid3D([2387,2201,2344,2279],0); -ELEMENTS[44717] = Fluid3D([2387,2201,2279,2480],0); -ELEMENTS[44718] = Fluid3D([5552,5474,5061,4784],0); -ELEMENTS[44719] = Fluid3D([3862,3527,3919,3593],0); -ELEMENTS[44720] = Fluid3D([17057,16982,16613,17063],0); -ELEMENTS[44721] = Fluid3D([17057,16982,17063,17370],0); -ELEMENTS[44722] = Fluid3D([16982,16613,17063,16952],0); -ELEMENTS[44723] = Fluid3D([17063,16982,16952,17370],0); -ELEMENTS[44724] = Fluid3D([16952,17063,17370,17272],0); -ELEMENTS[44725] = Fluid3D([16952,17063,17272,16686],0); -ELEMENTS[44726] = Fluid3D([16952,17063,16686,16613],0); -ELEMENTS[44727] = Fluid3D([14757,14355,15072,14452],0); -ELEMENTS[44728] = Fluid3D([10230,10170,11229,10089],0); -ELEMENTS[44729] = Fluid3D([14207,13844,13974,14494],0); -ELEMENTS[44730] = Fluid3D([13844,13974,14494,14334],0); -ELEMENTS[44731] = Fluid3D([13974,14494,14334,14801],0); -ELEMENTS[44732] = Fluid3D([13844,13974,14334,13921],0); -ELEMENTS[44733] = Fluid3D([13974,14207,14494,14801],0); -ELEMENTS[44734] = Fluid3D([13883,14710,14760,14924],0); -ELEMENTS[44735] = Fluid3D([14710,14760,14924,15629],0); -ELEMENTS[44736] = Fluid3D([17273,16947,16883,17342],0); -ELEMENTS[44737] = Fluid3D([7940,7501,7451,8344],0); -ELEMENTS[44738] = Fluid3D([8494,8072,8784,7536],0); -ELEMENTS[44739] = Fluid3D([15526,14828,15144,15138],0); -ELEMENTS[44740] = Fluid3D([5416,4901,5108,5682],0); -ELEMENTS[44741] = Fluid3D([2614,2337,2385,2438],0); -ELEMENTS[44742] = Fluid3D([12533,11843,12057,11423],0); -ELEMENTS[44743] = Fluid3D([16131,16123,16528,16544],0); -ELEMENTS[44744] = Fluid3D([17117,17219,17455,17285],0); -ELEMENTS[44745] = Fluid3D([17117,17219,17285,17050],0); -ELEMENTS[44746] = Fluid3D([11776,11744,12351,12783],0); -ELEMENTS[44747] = Fluid3D([2910,3087,2843,2820],0); -ELEMENTS[44748] = Fluid3D([5687,5753,5285,6112],0); -ELEMENTS[44749] = Fluid3D([3515,3885,3485,3829],0); -ELEMENTS[44750] = Fluid3D([3885,3485,3829,3560],0); -ELEMENTS[44751] = Fluid3D([4519,4860,4380,4362],0); -ELEMENTS[44752] = Fluid3D([4380,4519,4362,4003],0); -ELEMENTS[44753] = Fluid3D([4519,4362,4003,4014],0); -ELEMENTS[44754] = Fluid3D([12083,12565,12774,13290],0); -ELEMENTS[44755] = Fluid3D([14336,14498,13921,14216],0); -ELEMENTS[44756] = Fluid3D([10980,11985,11054,11467],0); -ELEMENTS[44757] = Fluid3D([11052,9977,10952,10223],0); -ELEMENTS[44758] = Fluid3D([10952,11052,10223,11213],0); -ELEMENTS[44759] = Fluid3D([10952,11052,11213,11910],0); -ELEMENTS[44760] = Fluid3D([11052,10223,11213,9977],0); -ELEMENTS[44761] = Fluid3D([11052,11213,11910,11658],0); -ELEMENTS[44762] = Fluid3D([10952,11052,11910,11389],0); -ELEMENTS[44763] = Fluid3D([15192,15302,15823,15720],0); -ELEMENTS[44764] = Fluid3D([16772,16994,17181,16943],0); -ELEMENTS[44765] = Fluid3D([16994,17181,16943,17290],0); -ELEMENTS[44766] = Fluid3D([16994,17181,17290,17639],0); -ELEMENTS[44767] = Fluid3D([16943,16994,17290,17033],0); -ELEMENTS[44768] = Fluid3D([17181,16943,17290,17368],0); -ELEMENTS[44769] = Fluid3D([17290,17181,17368,17639],0); -ELEMENTS[44770] = Fluid3D([7914,8781,8116,7831],0); -ELEMENTS[44771] = Fluid3D([10109,9911,11118,10372],0); -ELEMENTS[44772] = Fluid3D([16067,16336,16600,16108],0); -ELEMENTS[44773] = Fluid3D([17504,17858,17687,17822],0); -ELEMENTS[44774] = Fluid3D([7840,7395,8081,7585],0); -ELEMENTS[44775] = Fluid3D([6168,5934,6462,6412],0); -ELEMENTS[44776] = Fluid3D([5934,6462,6412,5845],0); -ELEMENTS[44777] = Fluid3D([15038,14365,14711,15105],0); -ELEMENTS[44778] = Fluid3D([8461,9236,8475,7908],0); -ELEMENTS[44779] = Fluid3D([4480,4601,4268,3988],0); -ELEMENTS[44780] = Fluid3D([10502,10465,10343,11272],0); -ELEMENTS[44781] = Fluid3D([10343,10502,11272,11483],0); -ELEMENTS[44782] = Fluid3D([10502,11272,11483,11897],0); -ELEMENTS[44783] = Fluid3D([10465,10343,11272,11033],0); -ELEMENTS[44784] = Fluid3D([4233,4416,4365,3962],0); -ELEMENTS[44785] = Fluid3D([4365,4233,3962,3928],0); -ELEMENTS[44786] = Fluid3D([4365,4233,3928,4287],0); -ELEMENTS[44787] = Fluid3D([4233,3962,3928,4142],0); -ELEMENTS[44788] = Fluid3D([4233,3928,4287,4142],0); -ELEMENTS[44789] = Fluid3D([4287,4233,4142,4695],0); -ELEMENTS[44790] = Fluid3D([3928,4287,4142,3660],0); -ELEMENTS[44791] = Fluid3D([4142,4287,4695,4606],0); -ELEMENTS[44792] = Fluid3D([4142,4287,4606,4293],0); -ELEMENTS[44793] = Fluid3D([4287,4233,4695,4365],0); -ELEMENTS[44794] = Fluid3D([4343,4202,4295,4466],0); -ELEMENTS[44795] = Fluid3D([8477,9164,8653,9936],0); -ELEMENTS[44796] = Fluid3D([3973,4403,3831,4016],0); -ELEMENTS[44797] = Fluid3D([16085,15829,15624,16241],0); -ELEMENTS[44798] = Fluid3D([16085,15829,16241,16350],0); -ELEMENTS[44799] = Fluid3D([16491,16871,16893,16954],0); -ELEMENTS[44800] = Fluid3D([16150,16273,15760,15612],0); -ELEMENTS[44801] = Fluid3D([16150,16273,15612,15835],0); -ELEMENTS[44802] = Fluid3D([15612,16150,15835,16019],0); -ELEMENTS[44803] = Fluid3D([4700,4662,5202,5401],0); -ELEMENTS[44804] = Fluid3D([4324,4633,4497,4737],0); -ELEMENTS[44805] = Fluid3D([4843,4756,5374,4840],0); -ELEMENTS[44806] = Fluid3D([4843,4756,4840,4193],0); -ELEMENTS[44807] = Fluid3D([15153,15801,14982,14914],0); -ELEMENTS[44808] = Fluid3D([1782,1846,1681,1706],0); -ELEMENTS[44809] = Fluid3D([15115,14960,14142,14802],0); -ELEMENTS[44810] = Fluid3D([11978,12706,12690,12702],0); -ELEMENTS[44811] = Fluid3D([13876,13960,14285,13374],0); -ELEMENTS[44812] = Fluid3D([9011,8365,7966,8638],0); -ELEMENTS[44813] = Fluid3D([8365,7966,8638,7425],0); -ELEMENTS[44814] = Fluid3D([9011,8365,8638,9336],0); -ELEMENTS[44815] = Fluid3D([8638,9011,9336,9674],0); -ELEMENTS[44816] = Fluid3D([9336,8638,9674,9281],0); -ELEMENTS[44817] = Fluid3D([9336,8638,9281,8520],0); -ELEMENTS[44818] = Fluid3D([9336,8638,8520,8365],0); -ELEMENTS[44819] = Fluid3D([9674,9336,9281,10561],0); -ELEMENTS[44820] = Fluid3D([8638,9281,8520,8046],0); -ELEMENTS[44821] = Fluid3D([9011,9336,9674,10313],0); -ELEMENTS[44822] = Fluid3D([9336,9674,10313,10561],0); -ELEMENTS[44823] = Fluid3D([9281,9336,8520,9105],0); -ELEMENTS[44824] = Fluid3D([8638,8520,8365,7425],0); -ELEMENTS[44825] = Fluid3D([8638,9011,9674,8934],0); -ELEMENTS[44826] = Fluid3D([9011,9674,8934,9892],0); -ELEMENTS[44827] = Fluid3D([9674,8934,9892,9851],0); -ELEMENTS[44828] = Fluid3D([8638,9011,8934,7966],0); -ELEMENTS[44829] = Fluid3D([13332,13754,14027,14513],0); -ELEMENTS[44830] = Fluid3D([18349,18250,18277,18200],0); -ELEMENTS[44831] = Fluid3D([3995,3538,3659,3961],0); -ELEMENTS[44832] = Fluid3D([11480,12142,11058,10835],0); -ELEMENTS[44833] = Fluid3D([15085,15041,15626,14829],0); -ELEMENTS[44834] = Fluid3D([3526,3198,3335,3183],0); -ELEMENTS[44835] = Fluid3D([3526,3198,3183,2969],0); -ELEMENTS[44836] = Fluid3D([14919,14466,15382,15289],0); -ELEMENTS[44837] = Fluid3D([15946,15682,16408,15892],0); -ELEMENTS[44838] = Fluid3D([8961,9672,9420,9998],0); -ELEMENTS[44839] = Fluid3D([7745,7925,8291,8858],0); -ELEMENTS[44840] = Fluid3D([4643,4137,4269,4104],0); -ELEMENTS[44841] = Fluid3D([3263,3229,2892,3120],0); -ELEMENTS[44842] = Fluid3D([15165,15567,15852,15036],0); -ELEMENTS[44843] = Fluid3D([2985,3364,3038,3070],0); -ELEMENTS[44844] = Fluid3D([2602,2994,2752,2800],0); -ELEMENTS[44845] = Fluid3D([12051,12474,12843,12876],0); -ELEMENTS[44846] = Fluid3D([16338,16425,16151,16431],0); -ELEMENTS[44847] = Fluid3D([16425,16151,16431,16052],0); -ELEMENTS[44848] = Fluid3D([16151,16431,16052,15806],0); -ELEMENTS[44849] = Fluid3D([16431,16425,16052,16438],0); -ELEMENTS[44850] = Fluid3D([16052,16431,16438,15806],0); -ELEMENTS[44851] = Fluid3D([16151,16338,16431,16098],0); -ELEMENTS[44852] = Fluid3D([16425,16151,16052,15492],0); -ELEMENTS[44853] = Fluid3D([16151,16052,15492,15806],0); -ELEMENTS[44854] = Fluid3D([10515,9538,10036,9634],0); -ELEMENTS[44855] = Fluid3D([4030,4075,4175,3569],0); -ELEMENTS[44856] = Fluid3D([11074,10350,10519,10980],0); -ELEMENTS[44857] = Fluid3D([10350,10519,10980,9728],0); -ELEMENTS[44858] = Fluid3D([7853,8332,7889,7652],0); -ELEMENTS[44859] = Fluid3D([9914,9741,10449,10257],0); -ELEMENTS[44860] = Fluid3D([1854,1789,1680,1783],0); -ELEMENTS[44861] = Fluid3D([1854,1789,1783,1881],0); -ELEMENTS[44862] = Fluid3D([1854,1789,1881,1917],0); -ELEMENTS[44863] = Fluid3D([17773,17821,17477,17575],0); -ELEMENTS[44864] = Fluid3D([6585,6296,6614,7015],0); -ELEMENTS[44865] = Fluid3D([6585,6296,7015,7022],0); -ELEMENTS[44866] = Fluid3D([6585,6296,7022,6625],0); -ELEMENTS[44867] = Fluid3D([7022,6585,6625,7217],0); -ELEMENTS[44868] = Fluid3D([6625,7022,7217,7258],0); -ELEMENTS[44869] = Fluid3D([7015,6585,7022,7406],0); -ELEMENTS[44870] = Fluid3D([6625,7022,7258,6387],0); -ELEMENTS[44871] = Fluid3D([6625,7022,6387,6296],0); -ELEMENTS[44872] = Fluid3D([6585,6296,6625,5829],0); -ELEMENTS[44873] = Fluid3D([7217,6625,7258,7154],0); -ELEMENTS[44874] = Fluid3D([6296,7015,7022,6746],0); -ELEMENTS[44875] = Fluid3D([5658,5186,5183,5113],0); -ELEMENTS[44876] = Fluid3D([6317,6142,6724,6153],0); -ELEMENTS[44877] = Fluid3D([14208,13527,14285,14436],0); -ELEMENTS[44878] = Fluid3D([14208,13527,14436,13553],0); -ELEMENTS[44879] = Fluid3D([14285,14208,14436,15048],0); -ELEMENTS[44880] = Fluid3D([14208,14436,15048,15051],0); -ELEMENTS[44881] = Fluid3D([13527,14436,13553,14168],0); -ELEMENTS[44882] = Fluid3D([14436,14285,15048,14903],0); -ELEMENTS[44883] = Fluid3D([15048,14436,14903,14936],0); -ELEMENTS[44884] = Fluid3D([15048,14436,14936,15584],0); -ELEMENTS[44885] = Fluid3D([14903,15048,14936,15584],0); -ELEMENTS[44886] = Fluid3D([10524,10920,9865,10681],0); -ELEMENTS[44887] = Fluid3D([7485,8014,7117,7852],0); -ELEMENTS[44888] = Fluid3D([17301,17661,17382,17559],0); -ELEMENTS[44889] = Fluid3D([17301,17661,17559,17819],0); -ELEMENTS[44890] = Fluid3D([17382,17301,17559,17262],0); -ELEMENTS[44891] = Fluid3D([2491,2541,2322,2581],0); -ELEMENTS[44892] = Fluid3D([17179,17186,16866,16958],0); -ELEMENTS[44893] = Fluid3D([9102,9024,9616,8194],0); -ELEMENTS[44894] = Fluid3D([11605,11973,12418,12366],0); -ELEMENTS[44895] = Fluid3D([7746,7525,7320,7065],0); -ELEMENTS[44896] = Fluid3D([7746,7525,7065,7701],0); -ELEMENTS[44897] = Fluid3D([7320,7746,7065,7332],0); -ELEMENTS[44898] = Fluid3D([7746,7065,7332,7089],0); -ELEMENTS[44899] = Fluid3D([7065,7332,7089,6571],0); -ELEMENTS[44900] = Fluid3D([7065,7332,6571,7320],0); -ELEMENTS[44901] = Fluid3D([7089,7065,6571,6822],0); -ELEMENTS[44902] = Fluid3D([7065,6571,6822,6789],0); -ELEMENTS[44903] = Fluid3D([7089,7065,6822,7701],0); -ELEMENTS[44904] = Fluid3D([8493,8147,8027,9148],0); -ELEMENTS[44905] = Fluid3D([13922,14183,13602,14473],0); -ELEMENTS[44906] = Fluid3D([13081,13288,13037,13763],0); -ELEMENTS[44907] = Fluid3D([13037,13081,13763,12790],0); -ELEMENTS[44908] = Fluid3D([13081,13763,12790,13555],0); -ELEMENTS[44909] = Fluid3D([13037,13081,12790,12032],0); -ELEMENTS[44910] = Fluid3D([12790,13081,13555,12476],0); -ELEMENTS[44911] = Fluid3D([12790,13081,12476,12032],0); -ELEMENTS[44912] = Fluid3D([15158,15112,14557,14976],0); -ELEMENTS[44913] = Fluid3D([7679,7013,7592,7700],0); -ELEMENTS[44914] = Fluid3D([7013,7592,7700,6922],0); -ELEMENTS[44915] = Fluid3D([7013,7592,6922,6827],0); -ELEMENTS[44916] = Fluid3D([15141,14424,14654,15115],0); -ELEMENTS[44917] = Fluid3D([14424,14654,15115,14142],0); -ELEMENTS[44918] = Fluid3D([14424,14654,14142,13884],0); -ELEMENTS[44919] = Fluid3D([14654,15115,14142,14802],0); -ELEMENTS[44920] = Fluid3D([5520,5882,5817,5332],0); -ELEMENTS[44921] = Fluid3D([5817,5520,5332,5606],0); -ELEMENTS[44922] = Fluid3D([5520,5882,5332,4919],0); -ELEMENTS[44923] = Fluid3D([5520,5332,5606,4972],0); -ELEMENTS[44924] = Fluid3D([5520,5332,4972,4919],0); -ELEMENTS[44925] = Fluid3D([5606,5520,4972,5036],0); -ELEMENTS[44926] = Fluid3D([5520,4972,5036,4927],0); -ELEMENTS[44927] = Fluid3D([5520,4972,4927,4919],0); -ELEMENTS[44928] = Fluid3D([4972,5036,4927,4614],0); -ELEMENTS[44929] = Fluid3D([4927,4972,4614,4529],0); -ELEMENTS[44930] = Fluid3D([4614,4927,4529,4906],0); -ELEMENTS[44931] = Fluid3D([4927,4529,4906,5070],0); -ELEMENTS[44932] = Fluid3D([4927,4529,5070,4919],0); -ELEMENTS[44933] = Fluid3D([4927,4529,4919,4766],0); -ELEMENTS[44934] = Fluid3D([4919,4927,4766,4972],0); -ELEMENTS[44935] = Fluid3D([4766,4919,4972,5332],0); -ELEMENTS[44936] = Fluid3D([4972,4766,5332,4763],0); -ELEMENTS[44937] = Fluid3D([4927,4766,4972,4395],0); -ELEMENTS[44938] = Fluid3D([4766,4972,4395,4629],0); -ELEMENTS[44939] = Fluid3D([4395,4766,4629,4763],0); -ELEMENTS[44940] = Fluid3D([4395,4766,4763,4919],0); -ELEMENTS[44941] = Fluid3D([4395,4766,4919,4529],0); -ELEMENTS[44942] = Fluid3D([4766,4763,4919,5332],0); -ELEMENTS[44943] = Fluid3D([4927,4529,4766,4395],0); -ELEMENTS[44944] = Fluid3D([4972,5036,4614,5020],0); -ELEMENTS[44945] = Fluid3D([4766,4972,4629,4763],0); -ELEMENTS[44946] = Fluid3D([4927,4972,4529,4395],0); -ELEMENTS[44947] = Fluid3D([5070,4927,4919,5520],0); -ELEMENTS[44948] = Fluid3D([4906,4927,5070,5625],0); -ELEMENTS[44949] = Fluid3D([5036,4927,4614,4906],0); -ELEMENTS[44950] = Fluid3D([5036,4927,4906,5520],0); -ELEMENTS[44951] = Fluid3D([5882,5817,5332,5324],0); -ELEMENTS[44952] = Fluid3D([5332,5606,4972,5212],0); -ELEMENTS[44953] = Fluid3D([4972,5332,5212,4763],0); -ELEMENTS[44954] = Fluid3D([9684,10270,9509,10737],0); -ELEMENTS[44955] = Fluid3D([2528,2550,2350,2207],0); -ELEMENTS[44956] = Fluid3D([7851,7609,8247,8441],0); -ELEMENTS[44957] = Fluid3D([2079,2237,2021,1941],0); -ELEMENTS[44958] = Fluid3D([2021,2079,1941,1821],0); -ELEMENTS[44959] = Fluid3D([16903,16685,16383,16814],0); -ELEMENTS[44960] = Fluid3D([10478,11533,11237,10627],0); -ELEMENTS[44961] = Fluid3D([10478,11533,10627,11268],0); -ELEMENTS[44962] = Fluid3D([13507,13697,14329,13859],0); -ELEMENTS[44963] = Fluid3D([14697,15108,15092,15360],0); -ELEMENTS[44964] = Fluid3D([12593,12856,13458,12947],0); -ELEMENTS[44965] = Fluid3D([13458,12593,12947,12162],0); -ELEMENTS[44966] = Fluid3D([17057,17306,17313,16717],0); -ELEMENTS[44967] = Fluid3D([6919,7273,7848,7806],0); -ELEMENTS[44968] = Fluid3D([4531,4679,5094,4883],0); -ELEMENTS[44969] = Fluid3D([4889,4292,4559,4603],0); -ELEMENTS[44970] = Fluid3D([15958,15699,15845,16393],0); -ELEMENTS[44971] = Fluid3D([4659,4224,4570,4428],0); -ELEMENTS[44972] = Fluid3D([13566,14099,14283,14584],0); -ELEMENTS[44973] = Fluid3D([8292,8464,7861,9230],0); -ELEMENTS[44974] = Fluid3D([10130,10275,10357,11168],0); -ELEMENTS[44975] = Fluid3D([16193,15824,15730,15346],0); -ELEMENTS[44976] = Fluid3D([5572,6303,5963,5715],0); -ELEMENTS[44977] = Fluid3D([7779,7491,6799,7572],0); -ELEMENTS[44978] = Fluid3D([9043,8502,8044,7749],0); -ELEMENTS[44979] = Fluid3D([14514,15009,15372,15501],0); -ELEMENTS[44980] = Fluid3D([15009,15372,15501,15785],0); -ELEMENTS[44981] = Fluid3D([15009,15372,15785,15646],0); -ELEMENTS[44982] = Fluid3D([18640,18653,18571,18596],0); -ELEMENTS[44983] = Fluid3D([8498,8466,8402,9145],0); -ELEMENTS[44984] = Fluid3D([16443,16540,16844,16497],0); -ELEMENTS[44985] = Fluid3D([4285,3939,3831,3894],0); -ELEMENTS[44986] = Fluid3D([6483,6330,5717,6097],0); -ELEMENTS[44987] = Fluid3D([12110,11391,12167,12665],0); -ELEMENTS[44988] = Fluid3D([9476,10217,9504,10087],0); -ELEMENTS[44989] = Fluid3D([16255,16236,16653,16823],0); -ELEMENTS[44990] = Fluid3D([10068,10154,9875,10712],0); -ELEMENTS[44991] = Fluid3D([4963,5403,5804,5613],0); -ELEMENTS[44992] = Fluid3D([5403,5804,5613,5466],0); -ELEMENTS[44993] = Fluid3D([5403,5804,5466,6111],0); -ELEMENTS[44994] = Fluid3D([5613,5403,5466,4910],0); -ELEMENTS[44995] = Fluid3D([5403,5466,4910,4833],0); -ELEMENTS[44996] = Fluid3D([5403,5466,4833,5205],0); -ELEMENTS[44997] = Fluid3D([5403,5804,6111,5576],0); -ELEMENTS[44998] = Fluid3D([3320,3700,3868,3904],0); -ELEMENTS[44999] = Fluid3D([6839,7036,7676,7252],0); -ELEMENTS[45000] = Fluid3D([3374,3116,3032,3402],0); -ELEMENTS[45001] = Fluid3D([14983,15057,15375,15799],0); -ELEMENTS[45002] = Fluid3D([14982,14502,15153,14601],0); -ELEMENTS[45003] = Fluid3D([17652,17497,17530,17195],0); -ELEMENTS[45004] = Fluid3D([17652,17497,17195,17410],0); -ELEMENTS[45005] = Fluid3D([15530,14905,14916,14811],0); -ELEMENTS[45006] = Fluid3D([15530,14905,14811,15135],0); -ELEMENTS[45007] = Fluid3D([14905,14811,15135,14254],0); -ELEMENTS[45008] = Fluid3D([14905,14916,14811,13997],0); -ELEMENTS[45009] = Fluid3D([14905,14811,14254,13997],0); -ELEMENTS[45010] = Fluid3D([5601,5178,5448,5477],0); -ELEMENTS[45011] = Fluid3D([4912,4593,4504,4022],0); -ELEMENTS[45012] = Fluid3D([13000,12118,12577,12332],0); -ELEMENTS[45013] = Fluid3D([2271,2266,2080,2334],0); -ELEMENTS[45014] = Fluid3D([2271,2266,2334,2563],0); -ELEMENTS[45015] = Fluid3D([4761,4300,4450,4378],0); -ELEMENTS[45016] = Fluid3D([4761,4300,4378,4324],0); -ELEMENTS[45017] = Fluid3D([13478,14358,14039,13985],0); -ELEMENTS[45018] = Fluid3D([10087,9487,10724,10305],0); -ELEMENTS[45019] = Fluid3D([5453,4996,4872,5063],0); -ELEMENTS[45020] = Fluid3D([4872,5453,5063,5200],0); -ELEMENTS[45021] = Fluid3D([4996,4872,5063,4525],0); -ELEMENTS[45022] = Fluid3D([4996,4872,4525,4602],0); -ELEMENTS[45023] = Fluid3D([4872,5063,4525,4583],0); -ELEMENTS[45024] = Fluid3D([4525,4872,4583,4500],0); -ELEMENTS[45025] = Fluid3D([4872,5063,4583,5200],0); -ELEMENTS[45026] = Fluid3D([5063,4583,5200,4753],0); -ELEMENTS[45027] = Fluid3D([5063,4583,4753,4568],0); -ELEMENTS[45028] = Fluid3D([4872,4525,4602,4757],0); -ELEMENTS[45029] = Fluid3D([4872,4525,4757,4266],0); -ELEMENTS[45030] = Fluid3D([4872,4525,4266,4500],0); -ELEMENTS[45031] = Fluid3D([6416,7023,7223,7312],0); -ELEMENTS[45032] = Fluid3D([4467,4926,4756,4840],0); -ELEMENTS[45033] = Fluid3D([6127,6405,6188,6946],0); -ELEMENTS[45034] = Fluid3D([6127,6405,6946,6888],0); -ELEMENTS[45035] = Fluid3D([6946,6127,6888,6307],0); -ELEMENTS[45036] = Fluid3D([6127,6888,6307,6421],0); -ELEMENTS[45037] = Fluid3D([6888,6307,6421,6942],0); -ELEMENTS[45038] = Fluid3D([6888,6307,6942,6747],0); -ELEMENTS[45039] = Fluid3D([6421,6888,6942,7588],0); -ELEMENTS[45040] = Fluid3D([6888,6942,7588,7284],0); -ELEMENTS[45041] = Fluid3D([6942,7588,7284,7303],0); -ELEMENTS[45042] = Fluid3D([6942,7588,7303,6928],0); -ELEMENTS[45043] = Fluid3D([7284,6942,7303,6567],0); -ELEMENTS[45044] = Fluid3D([7284,6942,6567,6747],0); -ELEMENTS[45045] = Fluid3D([6567,7284,6747,7300],0); -ELEMENTS[45046] = Fluid3D([6942,7303,6567,6592],0); -ELEMENTS[45047] = Fluid3D([7303,6567,6592,7300],0); -ELEMENTS[45048] = Fluid3D([6567,6942,6592,5905],0); -ELEMENTS[45049] = Fluid3D([6592,6567,5905,6287],0); -ELEMENTS[45050] = Fluid3D([6592,6567,6287,7300],0); -ELEMENTS[45051] = Fluid3D([6567,6287,7300,6747],0); -ELEMENTS[45052] = Fluid3D([6567,5905,6287,6307],0); -ELEMENTS[45053] = Fluid3D([6567,7284,7300,7303],0); -ELEMENTS[45054] = Fluid3D([7284,6747,7300,7634],0); -ELEMENTS[45055] = Fluid3D([6942,7303,6592,6928],0); -ELEMENTS[45056] = Fluid3D([6888,6942,7284,6747],0); -ELEMENTS[45057] = Fluid3D([7588,7284,7303,8505],0); -ELEMENTS[45058] = Fluid3D([6888,6946,6307,6747],0); -ELEMENTS[45059] = Fluid3D([6567,5905,6307,6942],0); -ELEMENTS[45060] = Fluid3D([6307,6567,6942,6747],0); -ELEMENTS[45061] = Fluid3D([6307,6567,6747,6287],0); -ELEMENTS[45062] = Fluid3D([6307,6421,6942,6162],0); -ELEMENTS[45063] = Fluid3D([13845,14000,13404,13667],0); -ELEMENTS[45064] = Fluid3D([6811,6104,6149,6212],0); -ELEMENTS[45065] = Fluid3D([8950,9357,10079,9353],0); -ELEMENTS[45066] = Fluid3D([2825,2568,2846,2627],0); -ELEMENTS[45067] = Fluid3D([10134,9402,9894,9252],0); -ELEMENTS[45068] = Fluid3D([11403,12216,11423,11843],0); -ELEMENTS[45069] = Fluid3D([15294,15878,15721,15566],0); -ELEMENTS[45070] = Fluid3D([13798,12704,13402,13758],0); -ELEMENTS[45071] = Fluid3D([17583,17226,17440,17713],0); -ELEMENTS[45072] = Fluid3D([10590,10800,9801,10641],0); -ELEMENTS[45073] = Fluid3D([4499,4776,4957,4306],0); -ELEMENTS[45074] = Fluid3D([15464,15816,15846,15480],0); -ELEMENTS[45075] = Fluid3D([3926,3522,3955,3505],0); -ELEMENTS[45076] = Fluid3D([8603,8515,9252,9592],0); -ELEMENTS[45077] = Fluid3D([11461,12252,11758,10628],0); -ELEMENTS[45078] = Fluid3D([3453,3397,3656,4029],0); -ELEMENTS[45079] = Fluid3D([11819,10951,10850,11280],0); -ELEMENTS[45080] = Fluid3D([5369,5755,5251,5822],0); -ELEMENTS[45081] = Fluid3D([5369,5755,5822,6349],0); -ELEMENTS[45082] = Fluid3D([11492,10891,10337,11310],0); -ELEMENTS[45083] = Fluid3D([12159,11543,12212,11645],0); -ELEMENTS[45084] = Fluid3D([15087,15272,15232,15735],0); -ELEMENTS[45085] = Fluid3D([10854,10761,11231,10123],0); -ELEMENTS[45086] = Fluid3D([16642,17048,16763,16561],0); -ELEMENTS[45087] = Fluid3D([16763,16642,16561,16146],0); -ELEMENTS[45088] = Fluid3D([16642,16561,16146,16741],0); -ELEMENTS[45089] = Fluid3D([16642,17048,16561,16741],0); -ELEMENTS[45090] = Fluid3D([8791,9456,8578,8704],0); -ELEMENTS[45091] = Fluid3D([8578,8791,8704,7808],0); -ELEMENTS[45092] = Fluid3D([12591,12612,11958,11924],0); -ELEMENTS[45093] = Fluid3D([12612,11958,11924,12087],0); -ELEMENTS[45094] = Fluid3D([12977,13720,14103,13161],0); -ELEMENTS[45095] = Fluid3D([13761,13156,13809,14098],0); -ELEMENTS[45096] = Fluid3D([12250,12193,11533,11634],0); -ELEMENTS[45097] = Fluid3D([16064,15500,15938,15772],0); -ELEMENTS[45098] = Fluid3D([14338,13721,13518,14262],0); -ELEMENTS[45099] = Fluid3D([7669,8366,8114,7377],0); -ELEMENTS[45100] = Fluid3D([8114,7669,7377,8034],0); -ELEMENTS[45101] = Fluid3D([7669,7377,8034,7619],0); -ELEMENTS[45102] = Fluid3D([8034,7669,7619,7468],0); -ELEMENTS[45103] = Fluid3D([8114,7669,8034,8474],0); -ELEMENTS[45104] = Fluid3D([7669,8034,8474,7468],0); -ELEMENTS[45105] = Fluid3D([7377,8114,8034,7773],0); -ELEMENTS[45106] = Fluid3D([7377,8034,7619,7773],0); -ELEMENTS[45107] = Fluid3D([7669,7377,7619,6830],0); -ELEMENTS[45108] = Fluid3D([7669,7377,6830,6505],0); -ELEMENTS[45109] = Fluid3D([7619,8034,7468,8266],0); -ELEMENTS[45110] = Fluid3D([7619,8034,8266,8442],0); -ELEMENTS[45111] = Fluid3D([7619,8034,8442,7773],0); -ELEMENTS[45112] = Fluid3D([7669,8366,7377,7222],0); -ELEMENTS[45113] = Fluid3D([7377,7669,7222,6505],0); -ELEMENTS[45114] = Fluid3D([15900,16167,16515,16194],0); -ELEMENTS[45115] = Fluid3D([12936,12898,13395,13678],0); -ELEMENTS[45116] = Fluid3D([12898,13395,13678,13165],0); -ELEMENTS[45117] = Fluid3D([12898,13395,13165,12885],0); -ELEMENTS[45118] = Fluid3D([13165,12898,12885,12281],0); -ELEMENTS[45119] = Fluid3D([13165,12898,12281,12165],0); -ELEMENTS[45120] = Fluid3D([12898,13395,12885,12107],0); -ELEMENTS[45121] = Fluid3D([13678,12898,13165,12936],0); -ELEMENTS[45122] = Fluid3D([12898,12885,12281,12107],0); -ELEMENTS[45123] = Fluid3D([12898,13165,12936,12165],0); -ELEMENTS[45124] = Fluid3D([12885,13165,12281,12663],0); -ELEMENTS[45125] = Fluid3D([13165,12281,12663,12968],0); -ELEMENTS[45126] = Fluid3D([12281,12885,12663,12362],0); -ELEMENTS[45127] = Fluid3D([2946,3254,3223,3181],0); -ELEMENTS[45128] = Fluid3D([7545,6917,6838,6934],0); -ELEMENTS[45129] = Fluid3D([14133,14534,14904,14910],0); -ELEMENTS[45130] = Fluid3D([18228,18249,18031,17952],0); -ELEMENTS[45131] = Fluid3D([8212,9063,8465,7934],0); -ELEMENTS[45132] = Fluid3D([8273,7586,8070,7359],0); -ELEMENTS[45133] = Fluid3D([8070,8273,7359,7716],0); -ELEMENTS[45134] = Fluid3D([16045,15954,15707,16130],0); -ELEMENTS[45135] = Fluid3D([12100,12639,12918,13036],0); -ELEMENTS[45136] = Fluid3D([3260,3201,3473,3169],0); -ELEMENTS[45137] = Fluid3D([3260,3201,3169,2949],0); -ELEMENTS[45138] = Fluid3D([11764,11134,11241,10861],0); -ELEMENTS[45139] = Fluid3D([8796,8192,8470,7929],0); -ELEMENTS[45140] = Fluid3D([8796,8192,7929,8437],0); -ELEMENTS[45141] = Fluid3D([8192,7929,8437,7603],0); -ELEMENTS[45142] = Fluid3D([8796,8192,8437,8752],0); -ELEMENTS[45143] = Fluid3D([12321,11579,12574,12436],0); -ELEMENTS[45144] = Fluid3D([16995,16907,16455,16665],0); -ELEMENTS[45145] = Fluid3D([16455,16995,16665,16762],0); -ELEMENTS[45146] = Fluid3D([16907,16455,16665,16566],0); -ELEMENTS[45147] = Fluid3D([1881,1783,1705,1789],0); -ELEMENTS[45148] = Fluid3D([12323,12535,11770,12985],0); -ELEMENTS[45149] = Fluid3D([12358,11629,12046,12392],0); -ELEMENTS[45150] = Fluid3D([12358,11629,12392,12382],0); -ELEMENTS[45151] = Fluid3D([11629,12392,12382,11762],0); -ELEMENTS[45152] = Fluid3D([12392,12382,11762,12737],0); -ELEMENTS[45153] = Fluid3D([12392,12382,12737,13177],0); -ELEMENTS[45154] = Fluid3D([11762,12392,12737,11737],0); -ELEMENTS[45155] = Fluid3D([17203,16920,16578,16791],0); -ELEMENTS[45156] = Fluid3D([17737,17456,17253,17692],0); -ELEMENTS[45157] = Fluid3D([17737,17456,17692,17873],0); -ELEMENTS[45158] = Fluid3D([17737,17456,17873,17415],0); -ELEMENTS[45159] = Fluid3D([17456,17253,17692,17435],0); -ELEMENTS[45160] = Fluid3D([17692,17737,17873,18108],0); -ELEMENTS[45161] = Fluid3D([5074,5515,5709,5249],0); -ELEMENTS[45162] = Fluid3D([13261,14003,13672,14071],0); -ELEMENTS[45163] = Fluid3D([13261,14003,14071,13964],0); -ELEMENTS[45164] = Fluid3D([9653,10548,9998,9285],0); -ELEMENTS[45165] = Fluid3D([4494,4275,3954,3890],0); -ELEMENTS[45166] = Fluid3D([2275,2098,2185,2083],0); -ELEMENTS[45167] = Fluid3D([7647,7737,6899,7517],0); -ELEMENTS[45168] = Fluid3D([17599,17775,17862,17881],0); -ELEMENTS[45169] = Fluid3D([17862,17599,17881,17655],0); -ELEMENTS[45170] = Fluid3D([17862,17599,17655,17628],0); -ELEMENTS[45171] = Fluid3D([17599,17881,17655,17690],0); -ELEMENTS[45172] = Fluid3D([16425,16052,16438,16002],0); -ELEMENTS[45173] = Fluid3D([16052,16438,16002,15961],0); -ELEMENTS[45174] = Fluid3D([16052,16438,15961,15806],0); -ELEMENTS[45175] = Fluid3D([16002,16052,15961,15492],0); -ELEMENTS[45176] = Fluid3D([15961,16052,15806,15492],0); -ELEMENTS[45177] = Fluid3D([16438,16002,15961,16623],0); -ELEMENTS[45178] = Fluid3D([12765,13681,13316,12888],0); -ELEMENTS[45179] = Fluid3D([12916,12048,12636,12172],0); -ELEMENTS[45180] = Fluid3D([15003,14498,15112,14651],0); -ELEMENTS[45181] = Fluid3D([15112,15003,14651,14976],0); -ELEMENTS[45182] = Fluid3D([14651,15112,14976,14557],0); -ELEMENTS[45183] = Fluid3D([9119,8966,9839,9576],0); -ELEMENTS[45184] = Fluid3D([9839,9119,9576,10191],0); -ELEMENTS[45185] = Fluid3D([9119,8966,9576,9115],0); -ELEMENTS[45186] = Fluid3D([9576,9119,9115,8816],0); -ELEMENTS[45187] = Fluid3D([8966,9576,9115,9514],0); -ELEMENTS[45188] = Fluid3D([9839,9119,10191,8884],0); -ELEMENTS[45189] = Fluid3D([15120,15143,14505,14925],0); -ELEMENTS[45190] = Fluid3D([15143,14505,14925,14691],0); -ELEMENTS[45191] = Fluid3D([8399,7894,7378,8228],0); -ELEMENTS[45192] = Fluid3D([7894,7378,8228,7153],0); -ELEMENTS[45193] = Fluid3D([13410,14260,14427,13740],0); -ELEMENTS[45194] = Fluid3D([13410,14260,13740,14501],0); -ELEMENTS[45195] = Fluid3D([14260,13740,14501,14427],0); -ELEMENTS[45196] = Fluid3D([6799,7491,6349,6862],0); -ELEMENTS[45197] = Fluid3D([6349,6799,6862,6253],0); -ELEMENTS[45198] = Fluid3D([6349,6799,6253,6352],0); -ELEMENTS[45199] = Fluid3D([6799,6862,6253,6984],0); -ELEMENTS[45200] = Fluid3D([6799,7491,6862,7572],0); -ELEMENTS[45201] = Fluid3D([16996,16733,16458,16679],0); -ELEMENTS[45202] = Fluid3D([16733,16458,16679,16393],0); -ELEMENTS[45203] = Fluid3D([16458,16679,16393,16346],0); -ELEMENTS[45204] = Fluid3D([12129,11230,11918,11397],0); -ELEMENTS[45205] = Fluid3D([10239,9909,9475,9213],0); -ELEMENTS[45206] = Fluid3D([10239,9909,9213,9429],0); -ELEMENTS[45207] = Fluid3D([2924,3189,3256,3158],0); -ELEMENTS[45208] = Fluid3D([18402,18151,18251,18272],0); -ELEMENTS[45209] = Fluid3D([6806,7337,7432,7613],0); -ELEMENTS[45210] = Fluid3D([17462,17424,17243,17008],0); -ELEMENTS[45211] = Fluid3D([12807,12937,12601,11999],0); -ELEMENTS[45212] = Fluid3D([12807,12937,11999,12343],0); -ELEMENTS[45213] = Fluid3D([12601,12807,11999,11650],0); -ELEMENTS[45214] = Fluid3D([7178,6996,7219,6450],0); -ELEMENTS[45215] = Fluid3D([7219,7178,6450,6646],0); -ELEMENTS[45216] = Fluid3D([8009,8104,8889,9156],0); -ELEMENTS[45217] = Fluid3D([8104,8889,9156,8382],0); -ELEMENTS[45218] = Fluid3D([8104,8889,8382,8330],0); -ELEMENTS[45219] = Fluid3D([17488,17770,17514,17871],0); -ELEMENTS[45220] = Fluid3D([11902,11217,11485,12300],0); -ELEMENTS[45221] = Fluid3D([11217,11485,12300,11385],0); -ELEMENTS[45222] = Fluid3D([11485,11902,12300,12194],0); -ELEMENTS[45223] = Fluid3D([12300,11485,12194,12463],0); -ELEMENTS[45224] = Fluid3D([11902,11217,12300,11768],0); -ELEMENTS[45225] = Fluid3D([11902,11217,11768,11861],0); -ELEMENTS[45226] = Fluid3D([11217,12300,11768,11964],0); -ELEMENTS[45227] = Fluid3D([8597,9242,9341,8364],0); -ELEMENTS[45228] = Fluid3D([4424,4838,4662,4721],0); -ELEMENTS[45229] = Fluid3D([14801,14770,15184,15508],0); -ELEMENTS[45230] = Fluid3D([14770,15184,15508,15807],0); -ELEMENTS[45231] = Fluid3D([15184,15508,15807,15682],0); -ELEMENTS[45232] = Fluid3D([14801,14770,15508,15611],0); -ELEMENTS[45233] = Fluid3D([10568,11039,10869,10581],0); -ELEMENTS[45234] = Fluid3D([16003,15511,15679,15884],0); -ELEMENTS[45235] = Fluid3D([15211,15286,14699,14875],0); -ELEMENTS[45236] = Fluid3D([2827,2553,2820,2532],0); -ELEMENTS[45237] = Fluid3D([5689,5411,6031,5887],0); -ELEMENTS[45238] = Fluid3D([16378,16200,16381,16525],0); -ELEMENTS[45239] = Fluid3D([11040,11289,10939,10335],0); -ELEMENTS[45240] = Fluid3D([11289,10939,10335,11381],0); -ELEMENTS[45241] = Fluid3D([10939,10335,11381,10582],0); -ELEMENTS[45242] = Fluid3D([10939,10335,10582,10190],0); -ELEMENTS[45243] = Fluid3D([10939,10335,10190,10394],0); -ELEMENTS[45244] = Fluid3D([10939,10335,10394,11040],0); -ELEMENTS[45245] = Fluid3D([10190,10939,10394,11043],0); -ELEMENTS[45246] = Fluid3D([10939,10394,11043,11076],0); -ELEMENTS[45247] = Fluid3D([10335,10190,10394,9575],0); -ELEMENTS[45248] = Fluid3D([10190,10394,9575,10526],0); -ELEMENTS[45249] = Fluid3D([10190,10939,11043,11128],0); -ELEMENTS[45250] = Fluid3D([11043,10190,11128,10526],0); -ELEMENTS[45251] = Fluid3D([11128,11043,10526,11649],0); -ELEMENTS[45252] = Fluid3D([11128,11043,11649,12336],0); -ELEMENTS[45253] = Fluid3D([11043,10526,11649,11076],0); -ELEMENTS[45254] = Fluid3D([10394,10190,11043,10526],0); -ELEMENTS[45255] = Fluid3D([10335,10190,9575,9353],0); -ELEMENTS[45256] = Fluid3D([10190,9575,9353,10000],0); -ELEMENTS[45257] = Fluid3D([10190,9575,10000,10526],0); -ELEMENTS[45258] = Fluid3D([10335,10582,10190,9353],0); -ELEMENTS[45259] = Fluid3D([10582,10939,10190,11128],0); -ELEMENTS[45260] = Fluid3D([11043,10394,10526,11076],0); -ELEMENTS[45261] = Fluid3D([10000,10190,10526,11128],0); -ELEMENTS[45262] = Fluid3D([10000,10190,11128,10628],0); -ELEMENTS[45263] = Fluid3D([10939,11043,11128,11814],0); -ELEMENTS[45264] = Fluid3D([10000,10190,10628,9516],0); -ELEMENTS[45265] = Fluid3D([11649,11043,11076,12336],0); -ELEMENTS[45266] = Fluid3D([9353,10190,10000,9516],0); -ELEMENTS[45267] = Fluid3D([13948,13901,13146,13669],0); -ELEMENTS[45268] = Fluid3D([13948,13901,13669,14741],0); -ELEMENTS[45269] = Fluid3D([3577,3625,3955,4094],0); -ELEMENTS[45270] = Fluid3D([9375,8798,9802,9658],0); -ELEMENTS[45271] = Fluid3D([8915,8666,8968,9741],0); -ELEMENTS[45272] = Fluid3D([8968,8915,9741,9321],0); -ELEMENTS[45273] = Fluid3D([11501,12036,12646,12238],0); -ELEMENTS[45274] = Fluid3D([12036,12646,12238,13097],0); -ELEMENTS[45275] = Fluid3D([6679,6030,6308,6490],0); -ELEMENTS[45276] = Fluid3D([17026,17322,16982,16857],0); -ELEMENTS[45277] = Fluid3D([13015,12126,11895,12073],0); -ELEMENTS[45278] = Fluid3D([12126,11895,12073,11243],0); -ELEMENTS[45279] = Fluid3D([12126,11895,11243,10876],0); -ELEMENTS[45280] = Fluid3D([12073,12126,11243,11783],0); -ELEMENTS[45281] = Fluid3D([13015,12126,12073,12659],0); -ELEMENTS[45282] = Fluid3D([11895,12073,11243,11474],0); -ELEMENTS[45283] = Fluid3D([12073,11243,11474,11571],0); -ELEMENTS[45284] = Fluid3D([11474,12073,11571,11542],0); -ELEMENTS[45285] = Fluid3D([12073,11243,11571,11783],0); -ELEMENTS[45286] = Fluid3D([11895,12073,11474,12551],0); -ELEMENTS[45287] = Fluid3D([11895,11243,10876,10720],0); -ELEMENTS[45288] = Fluid3D([11243,10876,10720,10666],0); -ELEMENTS[45289] = Fluid3D([11243,10876,10666,10606],0); -ELEMENTS[45290] = Fluid3D([10666,11243,10606,11571],0); -ELEMENTS[45291] = Fluid3D([10720,11243,10666,11474],0); -ELEMENTS[45292] = Fluid3D([11243,10666,11474,11571],0); -ELEMENTS[45293] = Fluid3D([11243,12126,10876,11185],0); -ELEMENTS[45294] = Fluid3D([10876,11243,11185,10606],0); -ELEMENTS[45295] = Fluid3D([11243,11185,10606,11783],0); -ELEMENTS[45296] = Fluid3D([11243,12126,11185,11783],0); -ELEMENTS[45297] = Fluid3D([8351,7639,7432,7443],0); -ELEMENTS[45298] = Fluid3D([10838,10337,10308,11492],0); -ELEMENTS[45299] = Fluid3D([4516,4273,4431,4145],0); -ELEMENTS[45300] = Fluid3D([4273,4431,4145,3876],0); -ELEMENTS[45301] = Fluid3D([4516,4273,4145,4089],0); -ELEMENTS[45302] = Fluid3D([15763,15332,15496,15785],0); -ELEMENTS[45303] = Fluid3D([16943,16869,16500,17266],0); -ELEMENTS[45304] = Fluid3D([6886,7508,7238,7814],0); -ELEMENTS[45305] = Fluid3D([6886,7508,7814,7611],0); -ELEMENTS[45306] = Fluid3D([2480,2279,2339,2166],0); -ELEMENTS[45307] = Fluid3D([12707,12908,13882,13211],0); -ELEMENTS[45308] = Fluid3D([12707,12908,13211,11946],0); -ELEMENTS[45309] = Fluid3D([13882,12707,13211,13684],0); -ELEMENTS[45310] = Fluid3D([12707,13211,13684,13269],0); -ELEMENTS[45311] = Fluid3D([12707,13211,13269,12255],0); -ELEMENTS[45312] = Fluid3D([13211,13882,13684,13269],0); -ELEMENTS[45313] = Fluid3D([12908,13882,13211,13273],0); -ELEMENTS[45314] = Fluid3D([16009,16304,16531,16594],0); -ELEMENTS[45315] = Fluid3D([17767,17837,17917,17450],0); -ELEMENTS[45316] = Fluid3D([9744,10290,10708,10781],0); -ELEMENTS[45317] = Fluid3D([6945,6518,7118,6208],0); -ELEMENTS[45318] = Fluid3D([9121,8298,8139,9141],0); -ELEMENTS[45319] = Fluid3D([6878,6588,7241,7253],0); -ELEMENTS[45320] = Fluid3D([8640,8417,8751,7777],0); -ELEMENTS[45321] = Fluid3D([17499,17338,17656,17848],0); -ELEMENTS[45322] = Fluid3D([11976,12565,13106,12774],0); -ELEMENTS[45323] = Fluid3D([16964,17243,16636,16968],0); -ELEMENTS[45324] = Fluid3D([2455,2567,2402,2714],0); -ELEMENTS[45325] = Fluid3D([8256,7928,7950,7197],0); -ELEMENTS[45326] = Fluid3D([7187,6576,7361,7429],0); -ELEMENTS[45327] = Fluid3D([6576,7361,7429,6872],0); -ELEMENTS[45328] = Fluid3D([7429,6576,6872,6657],0); -ELEMENTS[45329] = Fluid3D([6872,7429,6657,7519],0); -ELEMENTS[45330] = Fluid3D([7361,7429,6872,8179],0); -ELEMENTS[45331] = Fluid3D([13848,13333,13612,14368],0); -ELEMENTS[45332] = Fluid3D([11911,11656,10604,11438],0); -ELEMENTS[45333] = Fluid3D([11911,11656,11438,12438],0); -ELEMENTS[45334] = Fluid3D([11438,11911,12438,12099],0); -ELEMENTS[45335] = Fluid3D([11438,11911,12099,11726],0); -ELEMENTS[45336] = Fluid3D([17183,17094,17339,17723],0); -ELEMENTS[45337] = Fluid3D([6014,5582,6362,5477],0); -ELEMENTS[45338] = Fluid3D([1818,1875,1711,1804],0); -ELEMENTS[45339] = Fluid3D([6679,6468,7283,6900],0); -ELEMENTS[45340] = Fluid3D([10849,10265,10821,10008],0); -ELEMENTS[45341] = Fluid3D([10821,10849,10008,11001],0); -ELEMENTS[45342] = Fluid3D([10849,10265,10008,10126],0); -ELEMENTS[45343] = Fluid3D([10008,10849,10126,11001],0); -ELEMENTS[45344] = Fluid3D([15182,15913,15555,15603],0); -ELEMENTS[45345] = Fluid3D([9246,8886,8074,8814],0); -ELEMENTS[45346] = Fluid3D([9246,8886,8814,9954],0); -ELEMENTS[45347] = Fluid3D([15150,15522,15562,15325],0); -ELEMENTS[45348] = Fluid3D([15562,15150,15325,14658],0); -ELEMENTS[45349] = Fluid3D([15562,15150,14658,14783],0); -ELEMENTS[45350] = Fluid3D([15150,15325,14658,14791],0); -ELEMENTS[45351] = Fluid3D([14658,15150,14791,14400],0); -ELEMENTS[45352] = Fluid3D([15150,15325,14791,15522],0); -ELEMENTS[45353] = Fluid3D([14658,15150,14400,14783],0); -ELEMENTS[45354] = Fluid3D([15555,15376,15182,15603],0); -ELEMENTS[45355] = Fluid3D([15555,15376,15603,16296],0); -ELEMENTS[45356] = Fluid3D([18555,18541,18616,18595],0); -ELEMENTS[45357] = Fluid3D([18616,18555,18595,18647],0); -ELEMENTS[45358] = Fluid3D([18555,18541,18595,18517],0); -ELEMENTS[45359] = Fluid3D([18555,18595,18647,18565],0); -ELEMENTS[45360] = Fluid3D([15433,15863,15902,15542],0); -ELEMENTS[45361] = Fluid3D([15433,15863,15542,15118],0); -ELEMENTS[45362] = Fluid3D([14160,14304,13790,13323],0); -ELEMENTS[45363] = Fluid3D([6619,7446,6283,6575],0); -ELEMENTS[45364] = Fluid3D([7446,6283,6575,6447],0); -ELEMENTS[45365] = Fluid3D([6283,6575,6447,5805],0); -ELEMENTS[45366] = Fluid3D([6283,6619,6575,5808],0); -ELEMENTS[45367] = Fluid3D([6575,6984,7236,6253],0); -ELEMENTS[45368] = Fluid3D([16447,16429,16609,16260],0); -ELEMENTS[45369] = Fluid3D([10043,9705,10746,10268],0); -ELEMENTS[45370] = Fluid3D([11629,12046,12392,11481],0); -ELEMENTS[45371] = Fluid3D([11629,12046,11481,10806],0); -ELEMENTS[45372] = Fluid3D([12046,12392,11481,12922],0); -ELEMENTS[45373] = Fluid3D([12046,12392,12922,12358],0); -ELEMENTS[45374] = Fluid3D([12392,11629,11481,11762],0); -ELEMENTS[45375] = Fluid3D([17401,17406,17543,17045],0); -ELEMENTS[45376] = Fluid3D([13474,13508,13222,14201],0); -ELEMENTS[45377] = Fluid3D([11869,12748,12974,12420],0); -ELEMENTS[45378] = Fluid3D([11869,12748,12420,11453],0); -ELEMENTS[45379] = Fluid3D([1952,2064,1856,2008],0); -ELEMENTS[45380] = Fluid3D([1952,2064,2008,2114],0); -ELEMENTS[45381] = Fluid3D([2064,2008,2114,2182],0); -ELEMENTS[45382] = Fluid3D([1952,2064,2114,2062],0); -ELEMENTS[45383] = Fluid3D([2064,1856,2008,2075],0); -ELEMENTS[45384] = Fluid3D([2008,2064,2075,2182],0); -ELEMENTS[45385] = Fluid3D([8226,8584,7928,8471],0); -ELEMENTS[45386] = Fluid3D([7928,8226,8471,7354],0); -ELEMENTS[45387] = Fluid3D([5437,5434,4944,5113],0); -ELEMENTS[45388] = Fluid3D([16002,15975,16379,16425],0); -ELEMENTS[45389] = Fluid3D([15975,16379,16425,15794],0); -ELEMENTS[45390] = Fluid3D([16425,15975,15794,15492],0); -ELEMENTS[45391] = Fluid3D([6125,6723,6329,6792],0); -ELEMENTS[45392] = Fluid3D([16414,15948,16445,16098],0); -ELEMENTS[45393] = Fluid3D([17520,17380,17225,17174],0); -ELEMENTS[45394] = Fluid3D([6217,6559,6250,5885],0); -ELEMENTS[45395] = Fluid3D([6559,6250,5885,6337],0); -ELEMENTS[45396] = Fluid3D([16174,15884,15336,15511],0); -ELEMENTS[45397] = Fluid3D([16174,15884,15511,16003],0); -ELEMENTS[45398] = Fluid3D([14165,14719,15005,14347],0); -ELEMENTS[45399] = Fluid3D([14165,14719,14347,13520],0); -ELEMENTS[45400] = Fluid3D([9980,10675,10819,10297],0); -ELEMENTS[45401] = Fluid3D([11810,11211,11293,10403],0); -ELEMENTS[45402] = Fluid3D([9236,10155,9555,9686],0); -ELEMENTS[45403] = Fluid3D([9236,10155,9686,10221],0); -ELEMENTS[45404] = Fluid3D([8273,8633,8070,9153],0); -ELEMENTS[45405] = Fluid3D([14249,14320,13442,13914],0); -ELEMENTS[45406] = Fluid3D([14706,15137,15312,15442],0); -ELEMENTS[45407] = Fluid3D([8628,9221,9046,8831],0); -ELEMENTS[45408] = Fluid3D([8628,9221,8831,9514],0); -ELEMENTS[45409] = Fluid3D([15671,15874,15863,16230],0); -ELEMENTS[45410] = Fluid3D([15874,15863,16230,15902],0); -ELEMENTS[45411] = Fluid3D([15671,15874,16230,15717],0); -ELEMENTS[45412] = Fluid3D([12876,12051,12745,12843],0); -ELEMENTS[45413] = Fluid3D([13566,13264,13177,13754],0); -ELEMENTS[45414] = Fluid3D([9506,9771,10494,10862],0); -ELEMENTS[45415] = Fluid3D([4450,4682,5165,4977],0); -ELEMENTS[45416] = Fluid3D([3440,3398,3511,3144],0); -ELEMENTS[45417] = Fluid3D([3440,3398,3144,3036],0); -ELEMENTS[45418] = Fluid3D([3398,3144,3036,3248],0); -ELEMENTS[45419] = Fluid3D([3398,3144,3248,3174],0); -ELEMENTS[45420] = Fluid3D([3398,3144,3174,3751],0); -ELEMENTS[45421] = Fluid3D([11816,12365,11704,12306],0); -ELEMENTS[45422] = Fluid3D([11816,12365,12306,12985],0); -ELEMENTS[45423] = Fluid3D([12750,12795,11885,12980],0); -ELEMENTS[45424] = Fluid3D([1967,2071,1960,1848],0); -ELEMENTS[45425] = Fluid3D([13901,14342,13517,13998],0); -ELEMENTS[45426] = Fluid3D([5824,5941,5610,5164],0); -ELEMENTS[45427] = Fluid3D([7772,7198,7195,7292],0); -ELEMENTS[45428] = Fluid3D([13476,12882,13266,12756],0); -ELEMENTS[45429] = Fluid3D([12793,13279,13022,12320],0); -ELEMENTS[45430] = Fluid3D([13022,12793,12320,12805],0); -ELEMENTS[45431] = Fluid3D([3129,3605,3472,3617],0); -ELEMENTS[45432] = Fluid3D([3605,3472,3617,3727],0); -ELEMENTS[45433] = Fluid3D([3605,3472,3727,3295],0); -ELEMENTS[45434] = Fluid3D([3472,3727,3295,3719],0); -ELEMENTS[45435] = Fluid3D([3472,3727,3719,3617],0); -ELEMENTS[45436] = Fluid3D([3719,3472,3617,3206],0); -ELEMENTS[45437] = Fluid3D([3472,3617,3206,3129],0); -ELEMENTS[45438] = Fluid3D([3719,3472,3206,3291],0); -ELEMENTS[45439] = Fluid3D([3719,3472,3291,3320],0); -ELEMENTS[45440] = Fluid3D([3472,3291,3320,3150],0); -ELEMENTS[45441] = Fluid3D([3291,3320,3150,2928],0); -ELEMENTS[45442] = Fluid3D([3150,3291,2928,3206],0); -ELEMENTS[45443] = Fluid3D([3472,3291,3150,3206],0); -ELEMENTS[45444] = Fluid3D([3320,3150,2928,3148],0); -ELEMENTS[45445] = Fluid3D([3320,3150,3148,3295],0); -ELEMENTS[45446] = Fluid3D([3150,2928,3148,2687],0); -ELEMENTS[45447] = Fluid3D([3150,3148,3295,2892],0); -ELEMENTS[45448] = Fluid3D([3291,3320,2928,3138],0); -ELEMENTS[45449] = Fluid3D([3291,3719,3320,3506],0); -ELEMENTS[45450] = Fluid3D([3320,3291,3506,3138],0); -ELEMENTS[45451] = Fluid3D([3291,3719,3506,3206],0); -ELEMENTS[45452] = Fluid3D([13312,13042,12368,12798],0); -ELEMENTS[45453] = Fluid3D([13042,12368,12798,12363],0); -ELEMENTS[45454] = Fluid3D([12368,13312,12798,13099],0); -ELEMENTS[45455] = Fluid3D([18129,18183,18012,18314],0); -ELEMENTS[45456] = Fluid3D([2454,2524,2476,2844],0); -ELEMENTS[45457] = Fluid3D([9352,9577,9960,10541],0); -ELEMENTS[45458] = Fluid3D([4296,4364,4753,4153],0); -ELEMENTS[45459] = Fluid3D([15242,15287,15781,15534],0); -ELEMENTS[45460] = Fluid3D([15781,15242,15534,15560],0); -ELEMENTS[45461] = Fluid3D([15781,15242,15560,15288],0); -ELEMENTS[45462] = Fluid3D([15242,15534,15560,15235],0); -ELEMENTS[45463] = Fluid3D([15534,15781,15560,15923],0); -ELEMENTS[45464] = Fluid3D([15242,15287,15534,15397],0); -ELEMENTS[45465] = Fluid3D([15560,15534,15923,15620],0); -ELEMENTS[45466] = Fluid3D([5227,5335,4980,4469],0); -ELEMENTS[45467] = Fluid3D([3233,3062,2913,2884],0); -ELEMENTS[45468] = Fluid3D([2913,3233,2884,2904],0); -ELEMENTS[45469] = Fluid3D([2884,2913,2904,2638],0); -ELEMENTS[45470] = Fluid3D([3233,2884,2904,3014],0); -ELEMENTS[45471] = Fluid3D([2884,2904,3014,2644],0); -ELEMENTS[45472] = Fluid3D([2884,2904,2644,2638],0); -ELEMENTS[45473] = Fluid3D([3014,2884,2644,2919],0); -ELEMENTS[45474] = Fluid3D([3014,2884,2919,3340],0); -ELEMENTS[45475] = Fluid3D([2884,2644,2919,2563],0); -ELEMENTS[45476] = Fluid3D([3233,3062,2884,3340],0); -ELEMENTS[45477] = Fluid3D([2884,2919,3340,3062],0); -ELEMENTS[45478] = Fluid3D([2884,2919,3062,2711],0); -ELEMENTS[45479] = Fluid3D([2884,2919,2711,2563],0); -ELEMENTS[45480] = Fluid3D([2919,2711,2563,2833],0); -ELEMENTS[45481] = Fluid3D([2711,2563,2833,2779],0); -ELEMENTS[45482] = Fluid3D([2711,2563,2779,2537],0); -ELEMENTS[45483] = Fluid3D([2711,2563,2537,2884],0); -ELEMENTS[45484] = Fluid3D([2779,2711,2537,2818],0); -ELEMENTS[45485] = Fluid3D([2711,2537,2818,2884],0); -ELEMENTS[45486] = Fluid3D([2818,2711,2884,3062],0); -ELEMENTS[45487] = Fluid3D([2779,2711,2818,3062],0); -ELEMENTS[45488] = Fluid3D([2884,2818,3062,2913],0); -ELEMENTS[45489] = Fluid3D([2884,2818,2913,2638],0); -ELEMENTS[45490] = Fluid3D([2818,3062,2913,2840],0); -ELEMENTS[45491] = Fluid3D([2913,2818,2840,2527],0); -ELEMENTS[45492] = Fluid3D([2779,2711,3062,2919],0); -ELEMENTS[45493] = Fluid3D([2818,3062,2840,2779],0); -ELEMENTS[45494] = Fluid3D([2840,2818,2779,2527],0); -ELEMENTS[45495] = Fluid3D([3062,2840,2779,3112],0); -ELEMENTS[45496] = Fluid3D([2537,2779,2818,2527],0); -ELEMENTS[45497] = Fluid3D([2537,2818,2884,2638],0); -ELEMENTS[45498] = Fluid3D([2818,2913,2638,2527],0); -ELEMENTS[45499] = Fluid3D([8635,8629,8811,9459],0); -ELEMENTS[45500] = Fluid3D([8811,8635,9459,9260],0); -ELEMENTS[45501] = Fluid3D([16552,16367,16107,15970],0); -ELEMENTS[45502] = Fluid3D([15741,16079,15314,15709],0); -ELEMENTS[45503] = Fluid3D([3144,2971,3137,2747],0); -ELEMENTS[45504] = Fluid3D([17330,17498,17285,17606],0); -ELEMENTS[45505] = Fluid3D([17285,17330,17606,17455],0); -ELEMENTS[45506] = Fluid3D([17498,17285,17606,17554],0); -ELEMENTS[45507] = Fluid3D([17285,17606,17554,17219],0); -ELEMENTS[45508] = Fluid3D([17285,17606,17219,17455],0); -ELEMENTS[45509] = Fluid3D([4180,4028,3768,3640],0); -ELEMENTS[45510] = Fluid3D([4180,4028,3640,4241],0); -ELEMENTS[45511] = Fluid3D([4180,4028,4241,4500],0); -ELEMENTS[45512] = Fluid3D([9760,10681,9906,9865],0); -ELEMENTS[45513] = Fluid3D([11029,11989,11322,12063],0); -ELEMENTS[45514] = Fluid3D([18154,17965,17947,18026],0); -ELEMENTS[45515] = Fluid3D([10655,11219,9785,10962],0); -ELEMENTS[45516] = Fluid3D([5360,4957,5256,5885],0); -ELEMENTS[45517] = Fluid3D([18149,17897,18113,17895],0); -ELEMENTS[45518] = Fluid3D([3942,4170,3825,4166],0); -ELEMENTS[45519] = Fluid3D([4074,3754,4250,3905],0); -ELEMENTS[45520] = Fluid3D([15762,16176,15964,16558],0); -ELEMENTS[45521] = Fluid3D([14564,15197,14775,15097],0); -ELEMENTS[45522] = Fluid3D([17113,16831,16658,16889],0); -ELEMENTS[45523] = Fluid3D([15994,16545,16451,16121],0); -ELEMENTS[45524] = Fluid3D([5732,5132,5416,5682],0); -ELEMENTS[45525] = Fluid3D([16922,16592,16828,16451],0); -ELEMENTS[45526] = Fluid3D([16592,16828,16451,16064],0); -ELEMENTS[45527] = Fluid3D([18572,18606,18619,18645],0); -ELEMENTS[45528] = Fluid3D([8889,8531,7892,8009],0); -ELEMENTS[45529] = Fluid3D([8531,7892,8009,8163],0); -ELEMENTS[45530] = Fluid3D([8531,7892,8163,8404],0); -ELEMENTS[45531] = Fluid3D([8531,7892,8404,9072],0); -ELEMENTS[45532] = Fluid3D([8163,8531,8404,9104],0); -ELEMENTS[45533] = Fluid3D([8009,8531,8163,8540],0); -ELEMENTS[45534] = Fluid3D([8404,8531,9072,9104],0); -ELEMENTS[45535] = Fluid3D([9044,8084,7991,8446],0); -ELEMENTS[45536] = Fluid3D([7057,6308,6611,7307],0); -ELEMENTS[45537] = Fluid3D([16070,16508,16241,16577],0); -ELEMENTS[45538] = Fluid3D([10984,11722,10500,11223],0); -ELEMENTS[45539] = Fluid3D([2605,2798,2556,2366],0); -ELEMENTS[45540] = Fluid3D([4177,4296,3700,4116],0); -ELEMENTS[45541] = Fluid3D([14595,14293,13995,13382],0); -ELEMENTS[45542] = Fluid3D([13474,13914,13442,14320],0); -ELEMENTS[45543] = Fluid3D([12873,12837,13407,13722],0); -ELEMENTS[45544] = Fluid3D([13407,12873,13722,13147],0); -ELEMENTS[45545] = Fluid3D([12837,13407,13722,14048],0); -ELEMENTS[45546] = Fluid3D([13407,13722,14048,14660],0); -ELEMENTS[45547] = Fluid3D([13722,14048,14660,14431],0); -ELEMENTS[45548] = Fluid3D([14048,14660,14431,14922],0); -ELEMENTS[45549] = Fluid3D([8908,9132,8592,9149],0); -ELEMENTS[45550] = Fluid3D([8592,8908,9149,8310],0); -ELEMENTS[45551] = Fluid3D([9149,8592,8310,8044],0); -ELEMENTS[45552] = Fluid3D([8908,9149,8310,8271],0); -ELEMENTS[45553] = Fluid3D([8592,8908,8310,7852],0); -ELEMENTS[45554] = Fluid3D([8310,8592,7852,8044],0); -ELEMENTS[45555] = Fluid3D([10850,10951,10288,10181],0); -ELEMENTS[45556] = Fluid3D([17804,17835,17919,18106],0); -ELEMENTS[45557] = Fluid3D([18640,18673,18681,18650],0); -ELEMENTS[45558] = Fluid3D([8809,8772,7953,8666],0); -ELEMENTS[45559] = Fluid3D([3984,4084,3964,3530],0); -ELEMENTS[45560] = Fluid3D([9355,9276,8405,9312],0); -ELEMENTS[45561] = Fluid3D([9355,9276,9312,10524],0); -ELEMENTS[45562] = Fluid3D([9312,9355,10524,10049],0); -ELEMENTS[45563] = Fluid3D([9312,9355,10049,8618],0); -ELEMENTS[45564] = Fluid3D([9312,9355,8618,8405],0); -ELEMENTS[45565] = Fluid3D([17773,17851,17575,17499],0); -ELEMENTS[45566] = Fluid3D([13378,13115,12445,12862],0); -ELEMENTS[45567] = Fluid3D([13115,12445,12862,12598],0); -ELEMENTS[45568] = Fluid3D([12445,13378,12862,12293],0); -ELEMENTS[45569] = Fluid3D([16795,16721,17191,16940],0); -ELEMENTS[45570] = Fluid3D([16795,16721,16940,16406],0); -ELEMENTS[45571] = Fluid3D([17191,16795,16940,17278],0); -ELEMENTS[45572] = Fluid3D([16940,16795,16406,16647],0); -ELEMENTS[45573] = Fluid3D([16795,16940,17278,16694],0); -ELEMENTS[45574] = Fluid3D([16795,16940,16694,16647],0); -ELEMENTS[45575] = Fluid3D([16940,16694,16647,17029],0); -ELEMENTS[45576] = Fluid3D([16694,16647,17029,16549],0); -ELEMENTS[45577] = Fluid3D([16694,16647,16549,16120],0); -ELEMENTS[45578] = Fluid3D([17029,16694,16549,16754],0); -ELEMENTS[45579] = Fluid3D([16647,17029,16549,16774],0); -ELEMENTS[45580] = Fluid3D([16940,17278,16694,17029],0); -ELEMENTS[45581] = Fluid3D([7977,7674,7221,8186],0); -ELEMENTS[45582] = Fluid3D([18045,18148,17948,18219],0); -ELEMENTS[45583] = Fluid3D([12998,12540,13249,12464],0); -ELEMENTS[45584] = Fluid3D([17198,17084,17519,17240],0); -ELEMENTS[45585] = Fluid3D([17084,17519,17240,17525],0); -ELEMENTS[45586] = Fluid3D([13159,13493,12638,13367],0); -ELEMENTS[45587] = Fluid3D([13159,13493,13367,14179],0); -ELEMENTS[45588] = Fluid3D([12638,13159,13367,12523],0); -ELEMENTS[45589] = Fluid3D([13367,13159,14179,14073],0); -ELEMENTS[45590] = Fluid3D([5784,5687,5285,5064],0); -ELEMENTS[45591] = Fluid3D([5315,5764,5742,5195],0); -ELEMENTS[45592] = Fluid3D([3866,4129,4040,4542],0); -ELEMENTS[45593] = Fluid3D([10438,9383,9883,9563],0); -ELEMENTS[45594] = Fluid3D([4324,4633,4737,5037],0); -ELEMENTS[45595] = Fluid3D([4737,4324,5037,4637],0); -ELEMENTS[45596] = Fluid3D([4633,4737,5037,5133],0); -ELEMENTS[45597] = Fluid3D([12922,12795,13454,12220],0); -ELEMENTS[45598] = Fluid3D([6141,6216,5701,6231],0); -ELEMENTS[45599] = Fluid3D([14525,14009,13812,14506],0); -ELEMENTS[45600] = Fluid3D([7056,6394,6286,6611],0); -ELEMENTS[45601] = Fluid3D([5115,5720,5310,5255],0); -ELEMENTS[45602] = Fluid3D([5310,5115,5255,4688],0); -ELEMENTS[45603] = Fluid3D([5614,5370,5640,6259],0); -ELEMENTS[45604] = Fluid3D([6264,6166,5771,6615],0); -ELEMENTS[45605] = Fluid3D([7803,7921,8342,8756],0); -ELEMENTS[45606] = Fluid3D([3195,2866,2836,2781],0); -ELEMENTS[45607] = Fluid3D([16875,17065,16761,16800],0); -ELEMENTS[45608] = Fluid3D([7559,7448,7329,8250],0); -ELEMENTS[45609] = Fluid3D([1916,1893,1910,1713],0); -ELEMENTS[45610] = Fluid3D([11892,12696,12769,12112],0); -ELEMENTS[45611] = Fluid3D([9616,9834,10458,10114],0); -ELEMENTS[45612] = Fluid3D([6588,6157,5880,6180],0); -ELEMENTS[45613] = Fluid3D([17959,17652,17645,17770],0); -ELEMENTS[45614] = Fluid3D([17959,17652,17770,18023],0); -ELEMENTS[45615] = Fluid3D([17645,17959,17770,17947],0); -ELEMENTS[45616] = Fluid3D([7542,7574,6937,7664],0); -ELEMENTS[45617] = Fluid3D([7574,6937,7664,7273],0); -ELEMENTS[45618] = Fluid3D([3510,3638,3284,3189],0); -ELEMENTS[45619] = Fluid3D([9551,9288,8542,9203],0); -ELEMENTS[45620] = Fluid3D([9288,8542,9203,8491],0); -ELEMENTS[45621] = Fluid3D([9203,9288,8491,9039],0); -ELEMENTS[45622] = Fluid3D([9551,9288,9203,10359],0); -ELEMENTS[45623] = Fluid3D([14180,13903,14516,14592],0); -ELEMENTS[45624] = Fluid3D([13903,14516,14592,14012],0); -ELEMENTS[45625] = Fluid3D([5849,5515,5986,5951],0); -ELEMENTS[45626] = Fluid3D([5986,5849,5951,6667],0); -ELEMENTS[45627] = Fluid3D([5849,5515,5951,4934],0); -ELEMENTS[45628] = Fluid3D([5849,5951,6667,6192],0); -ELEMENTS[45629] = Fluid3D([5849,5951,6192,5585],0); -ELEMENTS[45630] = Fluid3D([5849,5951,5585,4934],0); -ELEMENTS[45631] = Fluid3D([6192,5849,5585,5787],0); -ELEMENTS[45632] = Fluid3D([3971,3751,3597,3537],0); -ELEMENTS[45633] = Fluid3D([3453,3078,3611,3269],0); -ELEMENTS[45634] = Fluid3D([3611,3453,3269,3663],0); -ELEMENTS[45635] = Fluid3D([3269,3611,3663,3843],0); -ELEMENTS[45636] = Fluid3D([3611,3663,3843,3453],0); -ELEMENTS[45637] = Fluid3D([3269,3611,3843,3545],0); -ELEMENTS[45638] = Fluid3D([3611,3843,3545,3851],0); -ELEMENTS[45639] = Fluid3D([3843,3611,3453,4029],0); -ELEMENTS[45640] = Fluid3D([3269,3611,3545,3296],0); -ELEMENTS[45641] = Fluid3D([3663,3269,3843,3486],0); -ELEMENTS[45642] = Fluid3D([3663,3843,3453,3871],0); -ELEMENTS[45643] = Fluid3D([3078,3611,3269,3361],0); -ELEMENTS[45644] = Fluid3D([3843,3663,3486,3900],0); -ELEMENTS[45645] = Fluid3D([3663,3843,3871,4098],0); -ELEMENTS[45646] = Fluid3D([14972,14924,14760,15373],0); -ELEMENTS[45647] = Fluid3D([14972,14924,15373,15434],0); -ELEMENTS[45648] = Fluid3D([14924,15373,15434,15629],0); -ELEMENTS[45649] = Fluid3D([15373,15434,15629,15594],0); -ELEMENTS[45650] = Fluid3D([15373,15434,15594,14972],0); -ELEMENTS[45651] = Fluid3D([15629,15373,15594,14760],0); -ELEMENTS[45652] = Fluid3D([15594,15373,14972,14760],0); -ELEMENTS[45653] = Fluid3D([14924,15373,15629,14760],0); -ELEMENTS[45654] = Fluid3D([8660,8997,7965,8648],0); -ELEMENTS[45655] = Fluid3D([18154,18257,17965,18279],0); -ELEMENTS[45656] = Fluid3D([18154,18257,18279,18377],0); -ELEMENTS[45657] = Fluid3D([18279,18154,18377,18258],0); -ELEMENTS[45658] = Fluid3D([18377,18279,18258,18482],0); -ELEMENTS[45659] = Fluid3D([18279,18154,18258,17947],0); -ELEMENTS[45660] = Fluid3D([18154,18377,18258,18361],0); -ELEMENTS[45661] = Fluid3D([18377,18258,18361,18482],0); -ELEMENTS[45662] = Fluid3D([18361,18377,18482,18471],0); -ELEMENTS[45663] = Fluid3D([18377,18482,18471,18560],0); -ELEMENTS[45664] = Fluid3D([18257,18279,18377,18476],0); -ELEMENTS[45665] = Fluid3D([18377,18279,18482,18476],0); -ELEMENTS[45666] = Fluid3D([17091,17108,17402,16909],0); -ELEMENTS[45667] = Fluid3D([15422,14774,15273,14723],0); -ELEMENTS[45668] = Fluid3D([11412,10976,11852,12179],0); -ELEMENTS[45669] = Fluid3D([5764,5992,6005,6879],0); -ELEMENTS[45670] = Fluid3D([5541,5744,5421,6233],0); -ELEMENTS[45671] = Fluid3D([5541,5744,6233,5747],0); -ELEMENTS[45672] = Fluid3D([12081,11312,12052,12487],0); -ELEMENTS[45673] = Fluid3D([5449,5717,6181,5991],0); -ELEMENTS[45674] = Fluid3D([5449,5717,5991,5612],0); -ELEMENTS[45675] = Fluid3D([5717,6181,5991,6390],0); -ELEMENTS[45676] = Fluid3D([5717,5991,5612,6390],0); -ELEMENTS[45677] = Fluid3D([5991,5612,6390,6034],0); -ELEMENTS[45678] = Fluid3D([6390,5991,6034,6181],0); -ELEMENTS[45679] = Fluid3D([2835,2749,2976,2634],0); -ELEMENTS[45680] = Fluid3D([2835,2749,2634,2451],0); -ELEMENTS[45681] = Fluid3D([2634,2835,2451,2911],0); -ELEMENTS[45682] = Fluid3D([2634,2835,2911,2976],0); -ELEMENTS[45683] = Fluid3D([2835,2911,2976,3244],0); -ELEMENTS[45684] = Fluid3D([2835,2911,3244,3037],0); -ELEMENTS[45685] = Fluid3D([2749,2976,2634,2724],0); -ELEMENTS[45686] = Fluid3D([2634,2749,2724,2389],0); -ELEMENTS[45687] = Fluid3D([2976,2634,2724,2652],0); -ELEMENTS[45688] = Fluid3D([2634,2724,2652,2389],0); -ELEMENTS[45689] = Fluid3D([2976,2634,2652,2733],0); -ELEMENTS[45690] = Fluid3D([2749,2976,2724,3064],0); -ELEMENTS[45691] = Fluid3D([3244,2835,3037,2854],0); -ELEMENTS[45692] = Fluid3D([18596,18528,18444,18414],0); -ELEMENTS[45693] = Fluid3D([3198,3335,3183,2851],0); -ELEMENTS[45694] = Fluid3D([3183,3198,2851,2969],0); -ELEMENTS[45695] = Fluid3D([3786,3927,3776,3362],0); -ELEMENTS[45696] = Fluid3D([4801,5132,4858,4463],0); -ELEMENTS[45697] = Fluid3D([7393,7113,7223,6490],0); -ELEMENTS[45698] = Fluid3D([13332,13139,13715,13193],0); -ELEMENTS[45699] = Fluid3D([13137,13435,13316,13826],0); -ELEMENTS[45700] = Fluid3D([13137,13435,13826,14218],0); -ELEMENTS[45701] = Fluid3D([15504,14986,15123,15481],0); -ELEMENTS[45702] = Fluid3D([15504,14986,15481,15844],0); -ELEMENTS[45703] = Fluid3D([16687,16833,16289,16804],0); -ELEMENTS[45704] = Fluid3D([15401,15163,15759,15834],0); -ELEMENTS[45705] = Fluid3D([1856,1919,1740,1897],0); -ELEMENTS[45706] = Fluid3D([7155,7659,8033,8020],0); -ELEMENTS[45707] = Fluid3D([7659,8033,8020,8514],0); -ELEMENTS[45708] = Fluid3D([8033,7155,8020,7581],0); -ELEMENTS[45709] = Fluid3D([4722,5280,5109,5115],0); -ELEMENTS[45710] = Fluid3D([5280,5109,5115,5461],0); -ELEMENTS[45711] = Fluid3D([5109,5115,5461,4669],0); -ELEMENTS[45712] = Fluid3D([8907,7991,8446,9044],0); -ELEMENTS[45713] = Fluid3D([4774,5200,4583,4753],0); -ELEMENTS[45714] = Fluid3D([12020,12152,12001,12878],0); -ELEMENTS[45715] = Fluid3D([12152,12001,12878,12580],0); -ELEMENTS[45716] = Fluid3D([12152,12001,12580,11855],0); -ELEMENTS[45717] = Fluid3D([12001,12580,11855,13125],0); -ELEMENTS[45718] = Fluid3D([12001,12878,12580,13125],0); -ELEMENTS[45719] = Fluid3D([17594,17434,17799,17560],0); -ELEMENTS[45720] = Fluid3D([17434,17799,17560,17444],0); -ELEMENTS[45721] = Fluid3D([17560,17434,17444,17297],0); -ELEMENTS[45722] = Fluid3D([10271,10642,10975,9871],0); -ELEMENTS[45723] = Fluid3D([7093,6797,6638,7538],0); -ELEMENTS[45724] = Fluid3D([17603,17826,17872,17485],0); -ELEMENTS[45725] = Fluid3D([9359,9924,9664,9330],0); -ELEMENTS[45726] = Fluid3D([9924,9664,9330,10959],0); -ELEMENTS[45727] = Fluid3D([10023,9240,9096,9215],0); -ELEMENTS[45728] = Fluid3D([10023,9240,9215,9610],0); -ELEMENTS[45729] = Fluid3D([11306,11034,10538,10235],0); -ELEMENTS[45730] = Fluid3D([9678,9621,9774,8905],0); -ELEMENTS[45731] = Fluid3D([9482,9642,9412,8706],0); -ELEMENTS[45732] = Fluid3D([16757,16562,17012,16680],0); -ELEMENTS[45733] = Fluid3D([16757,16562,16680,16268],0); -ELEMENTS[45734] = Fluid3D([16757,16562,16268,16699],0); -ELEMENTS[45735] = Fluid3D([16562,16680,16268,16360],0); -ELEMENTS[45736] = Fluid3D([16680,16757,16268,16135],0); -ELEMENTS[45737] = Fluid3D([16268,16562,16360,16264],0); -ELEMENTS[45738] = Fluid3D([16268,16562,16264,16699],0); -ELEMENTS[45739] = Fluid3D([16562,16680,16360,17012],0); -ELEMENTS[45740] = Fluid3D([8512,8207,8072,7610],0); -ELEMENTS[45741] = Fluid3D([7713,8220,8163,7597],0); -ELEMENTS[45742] = Fluid3D([2955,2869,3140,3458],0); -ELEMENTS[45743] = Fluid3D([11925,11067,11076,11649],0); -ELEMENTS[45744] = Fluid3D([7733,7411,8297,7661],0); -ELEMENTS[45745] = Fluid3D([18246,18035,18162,18016],0); -ELEMENTS[45746] = Fluid3D([18035,18162,18016,17968],0); -ELEMENTS[45747] = Fluid3D([9994,9466,10709,10462],0); -ELEMENTS[45748] = Fluid3D([9994,9466,10462,9826],0); -ELEMENTS[45749] = Fluid3D([9994,9466,9826,9379],0); -ELEMENTS[45750] = Fluid3D([10462,9994,9826,10614],0); -ELEMENTS[45751] = Fluid3D([9994,9826,10614,9379],0); -ELEMENTS[45752] = Fluid3D([9826,10462,10614,10240],0); -ELEMENTS[45753] = Fluid3D([10462,9994,10614,10709],0); -ELEMENTS[45754] = Fluid3D([9826,10614,9379,10240],0); -ELEMENTS[45755] = Fluid3D([9466,10462,9826,9544],0); -ELEMENTS[45756] = Fluid3D([9826,9466,9544,8793],0); -ELEMENTS[45757] = Fluid3D([10462,9826,9544,10240],0); -ELEMENTS[45758] = Fluid3D([9826,9544,10240,9459],0); -ELEMENTS[45759] = Fluid3D([9826,9544,9459,9379],0); -ELEMENTS[45760] = Fluid3D([9826,9544,9379,8793],0); -ELEMENTS[45761] = Fluid3D([10462,10614,10240,10978],0); -ELEMENTS[45762] = Fluid3D([10240,10462,10978,9544],0); -ELEMENTS[45763] = Fluid3D([10462,10614,10978,11117],0); -ELEMENTS[45764] = Fluid3D([10978,10462,11117,10357],0); -ELEMENTS[45765] = Fluid3D([10462,10614,11117,10709],0); -ELEMENTS[45766] = Fluid3D([11117,10462,10709,10357],0); -ELEMENTS[45767] = Fluid3D([10614,9994,9379,9752],0); -ELEMENTS[45768] = Fluid3D([9379,9826,8793,9466],0); -ELEMENTS[45769] = Fluid3D([10614,9994,9752,11254],0); -ELEMENTS[45770] = Fluid3D([10614,9994,11254,10709],0); -ELEMENTS[45771] = Fluid3D([10978,10462,10357,9466],0); -ELEMENTS[45772] = Fluid3D([10462,10357,9466,10709],0); -ELEMENTS[45773] = Fluid3D([10709,11117,10357,11582],0); -ELEMENTS[45774] = Fluid3D([10709,11117,11582,11254],0); -ELEMENTS[45775] = Fluid3D([10709,11117,11254,10614],0); -ELEMENTS[45776] = Fluid3D([11117,11254,10614,11327],0); -ELEMENTS[45777] = Fluid3D([11117,11254,11327,12187],0); -ELEMENTS[45778] = Fluid3D([11254,10614,11327,10410],0); -ELEMENTS[45779] = Fluid3D([10614,11327,10410,10542],0); -ELEMENTS[45780] = Fluid3D([10614,11117,11327,11147],0); -ELEMENTS[45781] = Fluid3D([11327,10614,11147,10542],0); -ELEMENTS[45782] = Fluid3D([14148,14042,14440,14929],0); -ELEMENTS[45783] = Fluid3D([16642,16685,16235,16383],0); -ELEMENTS[45784] = Fluid3D([12189,11758,12825,12244],0); -ELEMENTS[45785] = Fluid3D([12189,11758,12244,11128],0); -ELEMENTS[45786] = Fluid3D([12825,12189,12244,13278],0); -ELEMENTS[45787] = Fluid3D([17578,17851,17848,17499],0); -ELEMENTS[45788] = Fluid3D([14728,14930,14548,14219],0); -ELEMENTS[45789] = Fluid3D([4467,4738,4737,4219],0); -ELEMENTS[45790] = Fluid3D([4738,4737,4219,4091],0); -ELEMENTS[45791] = Fluid3D([4467,4738,4219,4261],0); -ELEMENTS[45792] = Fluid3D([4738,4219,4261,4389],0); -ELEMENTS[45793] = Fluid3D([4261,4738,4389,4230],0); -ELEMENTS[45794] = Fluid3D([15634,15644,15726,16207],0); -ELEMENTS[45795] = Fluid3D([5016,4661,5212,4763],0); -ELEMENTS[45796] = Fluid3D([2520,2833,2563,2779],0); -ELEMENTS[45797] = Fluid3D([10186,10092,9659,10386],0); -ELEMENTS[45798] = Fluid3D([10092,9659,10386,10370],0); -ELEMENTS[45799] = Fluid3D([10186,10092,10386,10782],0); -ELEMENTS[45800] = Fluid3D([10092,9659,10370,9860],0); -ELEMENTS[45801] = Fluid3D([15542,15142,15118,15621],0); -ELEMENTS[45802] = Fluid3D([14401,14568,14574,14117],0); -ELEMENTS[45803] = Fluid3D([17712,17958,17852,18102],0); -ELEMENTS[45804] = Fluid3D([11568,11508,11883,12291],0); -ELEMENTS[45805] = Fluid3D([11568,11508,12291,12542],0); -ELEMENTS[45806] = Fluid3D([12061,11571,11783,12485],0); -ELEMENTS[45807] = Fluid3D([12061,11571,12485,11542],0); -ELEMENTS[45808] = Fluid3D([11571,11783,12485,12073],0); -ELEMENTS[45809] = Fluid3D([12485,11571,12073,11542],0); -ELEMENTS[45810] = Fluid3D([5614,5030,4999,5468],0); -ELEMENTS[45811] = Fluid3D([15816,15846,15480,16346],0); -ELEMENTS[45812] = Fluid3D([11461,10582,12252,10628],0); -ELEMENTS[45813] = Fluid3D([11461,10582,10628,11128],0); -ELEMENTS[45814] = Fluid3D([2715,2705,2927,3122],0); -ELEMENTS[45815] = Fluid3D([12659,12485,11783,12073],0); -ELEMENTS[45816] = Fluid3D([12659,12485,12073,13015],0); -ELEMENTS[45817] = Fluid3D([2408,2426,2703,2366],0); -ELEMENTS[45818] = Fluid3D([16506,16324,16367,16633],0); -ELEMENTS[45819] = Fluid3D([16324,16367,16633,15852],0); -ELEMENTS[45820] = Fluid3D([16324,16367,15852,16065],0); -ELEMENTS[45821] = Fluid3D([15852,16324,16065,15828],0); -ELEMENTS[45822] = Fluid3D([17703,17710,18037,17714],0); -ELEMENTS[45823] = Fluid3D([4912,5474,5347,5355],0); -ELEMENTS[45824] = Fluid3D([18321,18257,18377,18466],0); -ELEMENTS[45825] = Fluid3D([3681,3586,4116,3907],0); -ELEMENTS[45826] = Fluid3D([14092,14864,14229,14380],0); -ELEMENTS[45827] = Fluid3D([14092,14864,14380,14736],0); -ELEMENTS[45828] = Fluid3D([14229,14092,14380,13675],0); -ELEMENTS[45829] = Fluid3D([14092,14380,13675,14736],0); -ELEMENTS[45830] = Fluid3D([14380,13675,14736,14282],0); -ELEMENTS[45831] = Fluid3D([14736,14380,14282,15059],0); -ELEMENTS[45832] = Fluid3D([14380,13675,14282,13329],0); -ELEMENTS[45833] = Fluid3D([14380,13675,13329,14229],0); -ELEMENTS[45834] = Fluid3D([14864,14380,14736,15059],0); -ELEMENTS[45835] = Fluid3D([6336,5937,5603,6038],0); -ELEMENTS[45836] = Fluid3D([15833,15268,15849,15137],0); -ELEMENTS[45837] = Fluid3D([11771,12232,12912,12727],0); -ELEMENTS[45838] = Fluid3D([16977,16794,17258,17237],0); -ELEMENTS[45839] = Fluid3D([16977,16794,17237,16883],0); -ELEMENTS[45840] = Fluid3D([3221,3009,2927,3313],0); -ELEMENTS[45841] = Fluid3D([6828,7279,7706,7297],0); -ELEMENTS[45842] = Fluid3D([6828,7279,7297,7154],0); -ELEMENTS[45843] = Fluid3D([7706,6828,7297,7094],0); -ELEMENTS[45844] = Fluid3D([6828,7297,7094,6809],0); -ELEMENTS[45845] = Fluid3D([18140,18166,18082,17945],0); -ELEMENTS[45846] = Fluid3D([10501,10089,11149,11174],0); -ELEMENTS[45847] = Fluid3D([10501,10089,11174,10551],0); -ELEMENTS[45848] = Fluid3D([11149,10501,11174,11429],0); -ELEMENTS[45849] = Fluid3D([8048,9067,8727,8282],0); -ELEMENTS[45850] = Fluid3D([2694,2768,2566,2637],0); -ELEMENTS[45851] = Fluid3D([2768,2566,2637,3032],0); -ELEMENTS[45852] = Fluid3D([2566,2694,2637,2398],0); -ELEMENTS[45853] = Fluid3D([2637,2566,2398,2464],0); -ELEMENTS[45854] = Fluid3D([2694,2637,2398,2570],0); -ELEMENTS[45855] = Fluid3D([2637,2398,2570,2394],0); -ELEMENTS[45856] = Fluid3D([2694,2637,2570,2889],0); -ELEMENTS[45857] = Fluid3D([2694,2637,2889,3025],0); -ELEMENTS[45858] = Fluid3D([2637,2570,2889,2708],0); -ELEMENTS[45859] = Fluid3D([2570,2889,2708,2659],0); -ELEMENTS[45860] = Fluid3D([2637,2570,2708,2394],0); -ELEMENTS[45861] = Fluid3D([2570,2708,2394,2659],0); -ELEMENTS[45862] = Fluid3D([2394,2570,2659,2642],0); -ELEMENTS[45863] = Fluid3D([2889,2637,2708,3067],0); -ELEMENTS[45864] = Fluid3D([2708,2889,3067,3010],0); -ELEMENTS[45865] = Fluid3D([2708,2889,3010,2659],0); -ELEMENTS[45866] = Fluid3D([2570,2659,2642,2889],0); -ELEMENTS[45867] = Fluid3D([2889,3067,3010,3427],0); -ELEMENTS[45868] = Fluid3D([2570,2694,2889,2642],0); -ELEMENTS[45869] = Fluid3D([2570,2694,2642,2417],0); -ELEMENTS[45870] = Fluid3D([2694,2642,2417,2662],0); -ELEMENTS[45871] = Fluid3D([2398,2570,2394,2417],0); -ELEMENTS[45872] = Fluid3D([2398,2694,2570,2417],0); -ELEMENTS[45873] = Fluid3D([2398,2694,2417,2494],0); -ELEMENTS[45874] = Fluid3D([2417,2398,2494,2215],0); -ELEMENTS[45875] = Fluid3D([2417,2398,2215,2394],0); -ELEMENTS[45876] = Fluid3D([2694,2417,2494,2662],0); -ELEMENTS[45877] = Fluid3D([2398,2694,2494,2566],0); -ELEMENTS[45878] = Fluid3D([2398,2494,2215,2300],0); -ELEMENTS[45879] = Fluid3D([2215,2398,2300,2174],0); -ELEMENTS[45880] = Fluid3D([11927,12125,12788,11849],0); -ELEMENTS[45881] = Fluid3D([12125,12788,11849,12191],0); -ELEMENTS[45882] = Fluid3D([7333,7339,7569,6765],0); -ELEMENTS[45883] = Fluid3D([7333,7339,6765,6534],0); -ELEMENTS[45884] = Fluid3D([7569,7333,6765,7285],0); -ELEMENTS[45885] = Fluid3D([4997,5265,5599,5742],0); -ELEMENTS[45886] = Fluid3D([13585,14093,14393,14520],0); -ELEMENTS[45887] = Fluid3D([14093,14393,14520,14828],0); -ELEMENTS[45888] = Fluid3D([14393,14520,14828,15144],0); -ELEMENTS[45889] = Fluid3D([14393,13585,14520,13758],0); -ELEMENTS[45890] = Fluid3D([14520,14393,13758,14375],0); -ELEMENTS[45891] = Fluid3D([14393,14520,15144,14375],0); -ELEMENTS[45892] = Fluid3D([13585,14520,13758,14093],0); -ELEMENTS[45893] = Fluid3D([4792,4991,4758,5245],0); -ELEMENTS[45894] = Fluid3D([4991,4758,5245,5633],0); -ELEMENTS[45895] = Fluid3D([4048,3655,3973,3831],0); -ELEMENTS[45896] = Fluid3D([16377,16234,15914,16112],0); -ELEMENTS[45897] = Fluid3D([16377,16234,16112,16740],0); -ELEMENTS[45898] = Fluid3D([16234,15914,16112,16029],0); -ELEMENTS[45899] = Fluid3D([16234,15914,16029,16418],0); -ELEMENTS[45900] = Fluid3D([16029,16234,16418,16740],0); -ELEMENTS[45901] = Fluid3D([16112,16234,16029,16452],0); -ELEMENTS[45902] = Fluid3D([16112,16234,16452,16740],0); -ELEMENTS[45903] = Fluid3D([16234,16452,16740,16029],0); -ELEMENTS[45904] = Fluid3D([15139,15357,14997,15701],0); -ELEMENTS[45905] = Fluid3D([15139,15357,15701,16131],0); -ELEMENTS[45906] = Fluid3D([3035,3189,3417,3510],0); -ELEMENTS[45907] = Fluid3D([14595,15161,14293,14272],0); -ELEMENTS[45908] = Fluid3D([14293,14595,14272,13382],0); -ELEMENTS[45909] = Fluid3D([14595,15161,14272,14315],0); -ELEMENTS[45910] = Fluid3D([14272,14595,14315,13891],0); -ELEMENTS[45911] = Fluid3D([11681,11336,11591,12538],0); -ELEMENTS[45912] = Fluid3D([6910,6262,6982,6690],0); -ELEMENTS[45913] = Fluid3D([9640,9360,9230,8753],0); -ELEMENTS[45914] = Fluid3D([17214,16910,17395,17376],0); -ELEMENTS[45915] = Fluid3D([12451,12266,11771,12912],0); -ELEMENTS[45916] = Fluid3D([14763,14370,15142,14732],0); -ELEMENTS[45917] = Fluid3D([6854,6836,6088,6318],0); -ELEMENTS[45918] = Fluid3D([6836,6088,6318,5758],0); -ELEMENTS[45919] = Fluid3D([17770,17410,17514,17652],0); -ELEMENTS[45920] = Fluid3D([15726,15526,15634,15822],0); -ELEMENTS[45921] = Fluid3D([15634,15726,15822,16207],0); -ELEMENTS[45922] = Fluid3D([9045,8791,8671,9631],0); -ELEMENTS[45923] = Fluid3D([17292,17067,16961,17421],0); -ELEMENTS[45924] = Fluid3D([6767,7252,7036,6839],0); -ELEMENTS[45925] = Fluid3D([17848,18122,17967,17960],0); -ELEMENTS[45926] = Fluid3D([17848,18122,17960,18160],0); -ELEMENTS[45927] = Fluid3D([9237,9977,10223,9981],0); -ELEMENTS[45928] = Fluid3D([7446,6619,7326,6575],0); -ELEMENTS[45929] = Fluid3D([2466,2327,2615,2374],0); -ELEMENTS[45930] = Fluid3D([17624,17841,17876,17650],0); -ELEMENTS[45931] = Fluid3D([8678,8735,9556,8305],0); -ELEMENTS[45932] = Fluid3D([13217,12814,13154,12657],0); -ELEMENTS[45933] = Fluid3D([7615,7666,8417,7866],0); -ELEMENTS[45934] = Fluid3D([4008,3676,3560,3874],0); -ELEMENTS[45935] = Fluid3D([8397,7753,8850,7860],0); -ELEMENTS[45936] = Fluid3D([8397,7753,7860,7258],0); -ELEMENTS[45937] = Fluid3D([8114,8324,7773,8010],0); -ELEMENTS[45938] = Fluid3D([8114,8324,8010,8596],0); -ELEMENTS[45939] = Fluid3D([6619,6766,6131,6044],0); -ELEMENTS[45940] = Fluid3D([12587,13016,12505,11900],0); -ELEMENTS[45941] = Fluid3D([16930,16984,16728,17345],0); -ELEMENTS[45942] = Fluid3D([16930,16984,17345,17326],0); -ELEMENTS[45943] = Fluid3D([16984,17345,17326,17548],0); -ELEMENTS[45944] = Fluid3D([17345,17326,17548,17531],0); -ELEMENTS[45945] = Fluid3D([14237,13616,14404,13926],0); -ELEMENTS[45946] = Fluid3D([12913,13318,12869,12627],0); -ELEMENTS[45947] = Fluid3D([6352,7056,6286,7132],0); -ELEMENTS[45948] = Fluid3D([5461,5714,5941,5158],0); -ELEMENTS[45949] = Fluid3D([5461,5714,5158,4800],0); -ELEMENTS[45950] = Fluid3D([4404,4987,5045,5234],0); -ELEMENTS[45951] = Fluid3D([17739,17737,17920,17992],0); -ELEMENTS[45952] = Fluid3D([17739,17737,17992,17873],0); -ELEMENTS[45953] = Fluid3D([17737,17992,17873,18108],0); -ELEMENTS[45954] = Fluid3D([17737,17920,17992,18108],0); -ELEMENTS[45955] = Fluid3D([17920,17992,18108,18209],0); -ELEMENTS[45956] = Fluid3D([17992,17873,18108,18019],0); -ELEMENTS[45957] = Fluid3D([17992,17873,18019,17739],0); -ELEMENTS[45958] = Fluid3D([18108,17992,18019,18170],0); -ELEMENTS[45959] = Fluid3D([17992,18019,18170,17985],0); -ELEMENTS[45960] = Fluid3D([18019,18170,17985,18147],0); -ELEMENTS[45961] = Fluid3D([18019,18170,18147,18316],0); -ELEMENTS[45962] = Fluid3D([18019,17992,17739,17985],0); -ELEMENTS[45963] = Fluid3D([17985,18019,18147,17699],0); -ELEMENTS[45964] = Fluid3D([18019,18170,18316,18283],0); -ELEMENTS[45965] = Fluid3D([18170,18316,18283,18339],0); -ELEMENTS[45966] = Fluid3D([18316,18283,18339,18446],0); -ELEMENTS[45967] = Fluid3D([18316,18283,18446,18298],0); -ELEMENTS[45968] = Fluid3D([18283,18339,18446,18330],0); -ELEMENTS[45969] = Fluid3D([18283,18339,18330,18177],0); -ELEMENTS[45970] = Fluid3D([18330,18283,18177,18446],0); -ELEMENTS[45971] = Fluid3D([18283,18170,18339,18108],0); -ELEMENTS[45972] = Fluid3D([18339,18283,18108,18177],0); -ELEMENTS[45973] = Fluid3D([18283,18108,18177,18138],0); -ELEMENTS[45974] = Fluid3D([18339,18446,18330,18465],0); -ELEMENTS[45975] = Fluid3D([18330,18339,18465,18288],0); -ELEMENTS[45976] = Fluid3D([18465,18330,18288,18397],0); -ELEMENTS[45977] = Fluid3D([18446,18330,18465,18397],0); -ELEMENTS[45978] = Fluid3D([18446,18330,18397,18177],0); -ELEMENTS[45979] = Fluid3D([18330,18397,18177,18288],0); -ELEMENTS[45980] = Fluid3D([18177,18330,18288,18339],0); -ELEMENTS[45981] = Fluid3D([14747,14455,13825,13860],0); -ELEMENTS[45982] = Fluid3D([16080,16461,16319,16631],0); -ELEMENTS[45983] = Fluid3D([16461,16319,16631,16970],0); -ELEMENTS[45984] = Fluid3D([16319,16080,16631,15951],0); -ELEMENTS[45985] = Fluid3D([16319,16080,15951,15543],0); -ELEMENTS[45986] = Fluid3D([16631,16319,15951,16487],0); -ELEMENTS[45987] = Fluid3D([16631,16319,16487,16968],0); -ELEMENTS[45988] = Fluid3D([16319,15951,16487,16263],0); -ELEMENTS[45989] = Fluid3D([16487,16319,16263,16968],0); -ELEMENTS[45990] = Fluid3D([10031,9833,9777,10814],0); -ELEMENTS[45991] = Fluid3D([8763,9334,9428,8375],0); -ELEMENTS[45992] = Fluid3D([2162,1916,2118,1922],0); -ELEMENTS[45993] = Fluid3D([11489,12356,12186,12261],0); -ELEMENTS[45994] = Fluid3D([10880,11412,11516,10388],0); -ELEMENTS[45995] = Fluid3D([15041,15488,15626,16074],0); -ELEMENTS[45996] = Fluid3D([4414,4673,4765,5088],0); -ELEMENTS[45997] = Fluid3D([4673,4765,5088,5409],0); -ELEMENTS[45998] = Fluid3D([12955,13743,13077,13609],0); -ELEMENTS[45999] = Fluid3D([12857,13365,13301,13710],0); -ELEMENTS[46000] = Fluid3D([16672,16801,16779,17095],0); -ELEMENTS[46001] = Fluid3D([16672,16801,17095,17180],0); -ELEMENTS[46002] = Fluid3D([17670,17555,17168,17515],0); -ELEMENTS[46003] = Fluid3D([8957,8519,9407,8081],0); -ELEMENTS[46004] = Fluid3D([13751,14076,13581,14242],0); -ELEMENTS[46005] = Fluid3D([13581,13751,14242,13918],0); -ELEMENTS[46006] = Fluid3D([14076,13581,14242,13707],0); -ELEMENTS[46007] = Fluid3D([13581,14242,13707,13649],0); -ELEMENTS[46008] = Fluid3D([13707,13581,13649,12732],0); -ELEMENTS[46009] = Fluid3D([13581,14242,13649,13918],0); -ELEMENTS[46010] = Fluid3D([6809,6568,5953,6611],0); -ELEMENTS[46011] = Fluid3D([6809,6568,6611,6828],0); -ELEMENTS[46012] = Fluid3D([14133,13258,13810,13126],0); -ELEMENTS[46013] = Fluid3D([13258,13810,13126,12932],0); -ELEMENTS[46014] = Fluid3D([13126,13258,12932,12310],0); -ELEMENTS[46015] = Fluid3D([13258,13810,12932,13588],0); -ELEMENTS[46016] = Fluid3D([12932,13258,13588,12635],0); -ELEMENTS[46017] = Fluid3D([13810,12932,13588,13536],0); -ELEMENTS[46018] = Fluid3D([12932,13588,13536,13051],0); -ELEMENTS[46019] = Fluid3D([13588,12932,12635,13051],0); -ELEMENTS[46020] = Fluid3D([8854,9003,9748,9660],0); -ELEMENTS[46021] = Fluid3D([14954,14180,14962,14973],0); -ELEMENTS[46022] = Fluid3D([14962,14954,14973,15533],0); -ELEMENTS[46023] = Fluid3D([14962,14954,15533,15625],0); -ELEMENTS[46024] = Fluid3D([14954,14973,15533,15146],0); -ELEMENTS[46025] = Fluid3D([14954,14973,15146,14180],0); -ELEMENTS[46026] = Fluid3D([15533,14954,15146,15625],0); -ELEMENTS[46027] = Fluid3D([14973,14962,15533,15338],0); -ELEMENTS[46028] = Fluid3D([14962,15533,15338,15840],0); -ELEMENTS[46029] = Fluid3D([15533,14973,15338,15244],0); -ELEMENTS[46030] = Fluid3D([14973,14962,15338,14617],0); -ELEMENTS[46031] = Fluid3D([14973,14962,14617,14180],0); -ELEMENTS[46032] = Fluid3D([14962,15338,14617,14798],0); -ELEMENTS[46033] = Fluid3D([15338,14973,14617,15175],0); -ELEMENTS[46034] = Fluid3D([14973,15338,15244,15175],0); -ELEMENTS[46035] = Fluid3D([15338,15244,15175,15936],0); -ELEMENTS[46036] = Fluid3D([5809,5656,5174,5637],0); -ELEMENTS[46037] = Fluid3D([5174,5809,5637,5087],0); -ELEMENTS[46038] = Fluid3D([5452,5968,6055,6225],0); -ELEMENTS[46039] = Fluid3D([5968,6055,6225,6421],0); -ELEMENTS[46040] = Fluid3D([5452,5968,6225,5350],0); -ELEMENTS[46041] = Fluid3D([2408,2386,2415,2728],0); -ELEMENTS[46042] = Fluid3D([17712,17391,17296,17674],0); -ELEMENTS[46043] = Fluid3D([17712,17391,17674,17852],0); -ELEMENTS[46044] = Fluid3D([13969,14093,13085,13758],0); -ELEMENTS[46045] = Fluid3D([18392,18459,18460,18564],0); -ELEMENTS[46046] = Fluid3D([4830,4783,4912,5347],0); -ELEMENTS[46047] = Fluid3D([8550,8306,8799,9374],0); -ELEMENTS[46048] = Fluid3D([8799,8550,9374,9517],0); -ELEMENTS[46049] = Fluid3D([8799,8550,9517,8649],0); -ELEMENTS[46050] = Fluid3D([7714,7510,7190,6915],0); -ELEMENTS[46051] = Fluid3D([7714,7510,6915,7096],0); -ELEMENTS[46052] = Fluid3D([7510,6915,7096,6768],0); -ELEMENTS[46053] = Fluid3D([6915,7714,7096,7311],0); -ELEMENTS[46054] = Fluid3D([6915,7714,7311,7190],0); -ELEMENTS[46055] = Fluid3D([7096,6915,7311,6541],0); -ELEMENTS[46056] = Fluid3D([7096,6915,6541,6351],0); -ELEMENTS[46057] = Fluid3D([6915,6541,6351,6404],0); -ELEMENTS[46058] = Fluid3D([6915,6541,6404,7190],0); -ELEMENTS[46059] = Fluid3D([6915,7311,6541,7190],0); -ELEMENTS[46060] = Fluid3D([7096,6915,6351,6768],0); -ELEMENTS[46061] = Fluid3D([6351,6915,6404,7190],0); -ELEMENTS[46062] = Fluid3D([6541,6351,6404,5748],0); -ELEMENTS[46063] = Fluid3D([15689,16024,15541,16078],0); -ELEMENTS[46064] = Fluid3D([15128,14986,15504,15483],0); -ELEMENTS[46065] = Fluid3D([15128,14986,15483,14645],0); -ELEMENTS[46066] = Fluid3D([16843,16680,16954,17241],0); -ELEMENTS[46067] = Fluid3D([18127,18246,18284,18428],0); -ELEMENTS[46068] = Fluid3D([18246,18284,18428,18337],0); -ELEMENTS[46069] = Fluid3D([18246,18284,18337,18162],0); -ELEMENTS[46070] = Fluid3D([18428,18246,18337,18468],0); -ELEMENTS[46071] = Fluid3D([18337,18246,18162,18016],0); -ELEMENTS[46072] = Fluid3D([18246,18337,18468,18191],0); -ELEMENTS[46073] = Fluid3D([18246,18337,18191,18016],0); -ELEMENTS[46074] = Fluid3D([12771,12703,12303,13259],0); -ELEMENTS[46075] = Fluid3D([12771,12703,13259,13736],0); -ELEMENTS[46076] = Fluid3D([13259,12771,13736,13306],0); -ELEMENTS[46077] = Fluid3D([13736,13259,13306,13884],0); -ELEMENTS[46078] = Fluid3D([13259,12771,13306,12303],0); -ELEMENTS[46079] = Fluid3D([4110,4424,4641,4700],0); -ELEMENTS[46080] = Fluid3D([12748,11749,12430,12319],0); -ELEMENTS[46081] = Fluid3D([7867,7873,7353,7188],0); -ELEMENTS[46082] = Fluid3D([7867,7873,7188,8055],0); -ELEMENTS[46083] = Fluid3D([12728,11956,12245,12481],0); -ELEMENTS[46084] = Fluid3D([12809,12681,12801,13775],0); -ELEMENTS[46085] = Fluid3D([9886,9928,9175,9029],0); -ELEMENTS[46086] = Fluid3D([9886,9928,9029,10228],0); -ELEMENTS[46087] = Fluid3D([9886,9928,10228,10809],0); -ELEMENTS[46088] = Fluid3D([9928,9175,9029,9476],0); -ELEMENTS[46089] = Fluid3D([9928,10228,10809,10087],0); -ELEMENTS[46090] = Fluid3D([3370,3207,3306,3561],0); -ELEMENTS[46091] = Fluid3D([3370,3207,3561,3620],0); -ELEMENTS[46092] = Fluid3D([4972,5020,5606,5036],0); -ELEMENTS[46093] = Fluid3D([14839,14389,14510,14956],0); -ELEMENTS[46094] = Fluid3D([13546,13765,13274,12212],0); -ELEMENTS[46095] = Fluid3D([4104,4371,4466,4643],0); -ELEMENTS[46096] = Fluid3D([17169,16732,16869,16858],0); -ELEMENTS[46097] = Fluid3D([18083,18000,18022,18260],0); -ELEMENTS[46098] = Fluid3D([18000,18022,18260,18094],0); -ELEMENTS[46099] = Fluid3D([18000,18022,18094,17688],0); -ELEMENTS[46100] = Fluid3D([11167,10323,10590,10994],0); -ELEMENTS[46101] = Fluid3D([14929,15365,15191,15583],0); -ELEMENTS[46102] = Fluid3D([14929,15365,15583,15356],0); -ELEMENTS[46103] = Fluid3D([4842,4423,4353,4754],0); -ELEMENTS[46104] = Fluid3D([4842,4423,4754,5057],0); -ELEMENTS[46105] = Fluid3D([4754,4842,5057,5379],0); -ELEMENTS[46106] = Fluid3D([5057,4754,5379,5334],0); -ELEMENTS[46107] = Fluid3D([4423,4754,5057,4305],0); -ELEMENTS[46108] = Fluid3D([4423,4353,4754,4181],0); -ELEMENTS[46109] = Fluid3D([4423,4754,4305,4181],0); -ELEMENTS[46110] = Fluid3D([10472,10458,11489,11121],0); -ELEMENTS[46111] = Fluid3D([12705,12101,12492,12847],0); -ELEMENTS[46112] = Fluid3D([8880,9567,8770,9443],0); -ELEMENTS[46113] = Fluid3D([12095,11743,12266,12727],0); -ELEMENTS[46114] = Fluid3D([13345,12438,12647,12979],0); -ELEMENTS[46115] = Fluid3D([12109,12045,11525,12589],0); -ELEMENTS[46116] = Fluid3D([12109,12045,12589,13303],0); -ELEMENTS[46117] = Fluid3D([7994,7733,8297,8829],0); -ELEMENTS[46118] = Fluid3D([8085,7682,7787,7237],0); -ELEMENTS[46119] = Fluid3D([7682,7787,7237,6854],0); -ELEMENTS[46120] = Fluid3D([7787,8085,7237,8551],0); -ELEMENTS[46121] = Fluid3D([7787,8085,8551,8298],0); -ELEMENTS[46122] = Fluid3D([1966,2143,1976,2109],0); -ELEMENTS[46123] = Fluid3D([15094,15376,14439,15182],0); -ELEMENTS[46124] = Fluid3D([13087,13307,13283,13932],0); -ELEMENTS[46125] = Fluid3D([13087,13307,13932,13774],0); -ELEMENTS[46126] = Fluid3D([13307,13283,13932,14116],0); -ELEMENTS[46127] = Fluid3D([15899,15398,15380,15308],0); -ELEMENTS[46128] = Fluid3D([15540,15148,14795,15198],0); -ELEMENTS[46129] = Fluid3D([15148,14795,15198,14776],0); -ELEMENTS[46130] = Fluid3D([14795,15198,14776,14833],0); -ELEMENTS[46131] = Fluid3D([15148,14795,14776,14392],0); -ELEMENTS[46132] = Fluid3D([15148,14795,14392,14415],0); -ELEMENTS[46133] = Fluid3D([14795,14776,14392,14127],0); -ELEMENTS[46134] = Fluid3D([14776,14392,14127,14734],0); -ELEMENTS[46135] = Fluid3D([14795,14776,14127,14833],0); -ELEMENTS[46136] = Fluid3D([14776,14392,14734,15148],0); -ELEMENTS[46137] = Fluid3D([14392,14734,15148,15123],0); -ELEMENTS[46138] = Fluid3D([14392,15148,14415,15123],0); -ELEMENTS[46139] = Fluid3D([14795,14392,14415,13797],0); -ELEMENTS[46140] = Fluid3D([14392,14415,13797,13896],0); -ELEMENTS[46141] = Fluid3D([14392,14415,13896,14443],0); -ELEMENTS[46142] = Fluid3D([13896,14392,14443,14734],0); -ELEMENTS[46143] = Fluid3D([14392,14443,14734,15123],0); -ELEMENTS[46144] = Fluid3D([13896,14392,14734,14127],0); -ELEMENTS[46145] = Fluid3D([13896,14392,14127,13882],0); -ELEMENTS[46146] = Fluid3D([13797,14392,13896,13882],0); -ELEMENTS[46147] = Fluid3D([14392,14415,14443,15123],0); -ELEMENTS[46148] = Fluid3D([14443,13896,14734,14288],0); -ELEMENTS[46149] = Fluid3D([14443,14734,15123,14705],0); -ELEMENTS[46150] = Fluid3D([14443,14734,14705,14288],0); -ELEMENTS[46151] = Fluid3D([15123,14443,14705,14464],0); -ELEMENTS[46152] = Fluid3D([14443,14705,14464,14002],0); -ELEMENTS[46153] = Fluid3D([14443,14705,14002,14288],0); -ELEMENTS[46154] = Fluid3D([14705,14002,14288,14235],0); -ELEMENTS[46155] = Fluid3D([14705,14464,14002,14731],0); -ELEMENTS[46156] = Fluid3D([15123,14443,14464,14415],0); -ELEMENTS[46157] = Fluid3D([14002,14705,14731,14235],0); -ELEMENTS[46158] = Fluid3D([14392,14795,14127,13882],0); -ELEMENTS[46159] = Fluid3D([14415,13896,14443,13406],0); -ELEMENTS[46160] = Fluid3D([14415,13797,13896,13406],0); -ELEMENTS[46161] = Fluid3D([13797,13896,13406,12769],0); -ELEMENTS[46162] = Fluid3D([14795,15540,15198,14958],0); -ELEMENTS[46163] = Fluid3D([15198,14795,14958,14374],0); -ELEMENTS[46164] = Fluid3D([14705,15123,14464,15194],0); -ELEMENTS[46165] = Fluid3D([15540,15198,14958,15595],0); -ELEMENTS[46166] = Fluid3D([14464,14443,14002,13441],0); -ELEMENTS[46167] = Fluid3D([16543,16229,16710,16606],0); -ELEMENTS[46168] = Fluid3D([7633,7768,7346,7123],0); -ELEMENTS[46169] = Fluid3D([2134,2092,2066,1924],0); -ELEMENTS[46170] = Fluid3D([6109,6179,5944,6720],0); -ELEMENTS[46171] = Fluid3D([10742,10099,10147,10349],0); -ELEMENTS[46172] = Fluid3D([13876,13141,13374,12647],0); -ELEMENTS[46173] = Fluid3D([7839,8256,7950,7197],0); -ELEMENTS[46174] = Fluid3D([13139,13475,12473,12737],0); -ELEMENTS[46175] = Fluid3D([5997,5431,5660,5342],0); -ELEMENTS[46176] = Fluid3D([12899,13126,13171,12386],0); -ELEMENTS[46177] = Fluid3D([3432,3339,3234,3595],0); -ELEMENTS[46178] = Fluid3D([5151,4992,5663,4999],0); -ELEMENTS[46179] = Fluid3D([6533,6746,6191,7158],0); -ELEMENTS[46180] = Fluid3D([6002,6370,6491,6779],0); -ELEMENTS[46181] = Fluid3D([17457,17709,17797,17654],0); -ELEMENTS[46182] = Fluid3D([3247,3514,3132,3075],0); -ELEMENTS[46183] = Fluid3D([3143,3290,2978,2948],0); -ELEMENTS[46184] = Fluid3D([6391,7159,7224,6989],0); -ELEMENTS[46185] = Fluid3D([7159,7224,6989,7773],0); -ELEMENTS[46186] = Fluid3D([7224,6391,6989,6245],0); -ELEMENTS[46187] = Fluid3D([12274,11307,12012,10689],0); -ELEMENTS[46188] = Fluid3D([11307,12012,10689,10770],0); -ELEMENTS[46189] = Fluid3D([10689,11307,10770,10144],0); -ELEMENTS[46190] = Fluid3D([12274,11307,10689,11781],0); -ELEMENTS[46191] = Fluid3D([11845,12230,11358,11247],0); -ELEMENTS[46192] = Fluid3D([12230,11358,11247,11655],0); -ELEMENTS[46193] = Fluid3D([11358,11845,11247,10871],0); -ELEMENTS[46194] = Fluid3D([18091,17952,18177,18057],0); -ELEMENTS[46195] = Fluid3D([10605,10209,9610,9290],0); -ELEMENTS[46196] = Fluid3D([16274,16019,16150,16380],0); -ELEMENTS[46197] = Fluid3D([2449,2675,2314,2562],0); -ELEMENTS[46198] = Fluid3D([2449,2675,2562,2723],0); -ELEMENTS[46199] = Fluid3D([2449,2675,2723,2595],0); -ELEMENTS[46200] = Fluid3D([3754,3411,3583,3762],0); -ELEMENTS[46201] = Fluid3D([3411,3583,3762,3334],0); -ELEMENTS[46202] = Fluid3D([3754,3411,3762,3334],0); -ELEMENTS[46203] = Fluid3D([18248,18050,18132,18333],0); -ELEMENTS[46204] = Fluid3D([2721,2762,2820,3147],0); -ELEMENTS[46205] = Fluid3D([17189,17377,17248,16886],0); -ELEMENTS[46206] = Fluid3D([17189,17377,16886,16931],0); -ELEMENTS[46207] = Fluid3D([15928,15693,16360,15831],0); -ELEMENTS[46208] = Fluid3D([15671,15863,15328,16037],0); -ELEMENTS[46209] = Fluid3D([15328,15671,16037,15776],0); -ELEMENTS[46210] = Fluid3D([15328,15671,15776,15026],0); -ELEMENTS[46211] = Fluid3D([15671,16037,15776,16413],0); -ELEMENTS[46212] = Fluid3D([15671,15863,16037,16230],0); -ELEMENTS[46213] = Fluid3D([9088,9143,10118,10479],0); -ELEMENTS[46214] = Fluid3D([7372,7995,7917,7662],0); -ELEMENTS[46215] = Fluid3D([7372,7995,7662,7107],0); -ELEMENTS[46216] = Fluid3D([2900,2875,2836,3343],0); -ELEMENTS[46217] = Fluid3D([3575,3479,3367,3071],0); -ELEMENTS[46218] = Fluid3D([17774,17597,17390,17541],0); -ELEMENTS[46219] = Fluid3D([17774,17597,17541,17893],0); -ELEMENTS[46220] = Fluid3D([7542,8308,7220,8509],0); -ELEMENTS[46221] = Fluid3D([3331,3812,3666,3530],0); -ELEMENTS[46222] = Fluid3D([2620,2706,2427,2547],0); -ELEMENTS[46223] = Fluid3D([7813,7544,8517,7893],0); -ELEMENTS[46224] = Fluid3D([4928,5163,4632,5027],0); -ELEMENTS[46225] = Fluid3D([17924,17960,18160,17848],0); -ELEMENTS[46226] = Fluid3D([14701,14965,14361,14214],0); -ELEMENTS[46227] = Fluid3D([14733,14693,14342,14741],0); -ELEMENTS[46228] = Fluid3D([15443,15893,16099,15848],0); -ELEMENTS[46229] = Fluid3D([10096,10937,10810,10233],0); -ELEMENTS[46230] = Fluid3D([9203,8764,8491,8542],0); -ELEMENTS[46231] = Fluid3D([10847,10525,10563,11613],0); -ELEMENTS[46232] = Fluid3D([17851,18047,18139,17967],0); -ELEMENTS[46233] = Fluid3D([6238,6501,6062,6887],0); -ELEMENTS[46234] = Fluid3D([16959,16469,16715,16218],0); -ELEMENTS[46235] = Fluid3D([14118,13829,14601,14471],0); -ELEMENTS[46236] = Fluid3D([14601,14118,14471,14502],0); -ELEMENTS[46237] = Fluid3D([14118,14471,14502,14068],0); -ELEMENTS[46238] = Fluid3D([14471,14502,14068,14982],0); -ELEMENTS[46239] = Fluid3D([14471,14502,14982,14601],0); -ELEMENTS[46240] = Fluid3D([13829,14601,14471,14914],0); -ELEMENTS[46241] = Fluid3D([14601,14471,14914,14982],0); -ELEMENTS[46242] = Fluid3D([14471,14914,14982,14796],0); -ELEMENTS[46243] = Fluid3D([14471,14914,14796,14280],0); -ELEMENTS[46244] = Fluid3D([14914,14796,14280,14216],0); -ELEMENTS[46245] = Fluid3D([14471,14914,14280,13829],0); -ELEMENTS[46246] = Fluid3D([14280,14471,13829,14068],0); -ELEMENTS[46247] = Fluid3D([14914,14280,13829,14498],0); -ELEMENTS[46248] = Fluid3D([14914,14280,14498,14216],0); -ELEMENTS[46249] = Fluid3D([14280,14471,14068,14796],0); -ELEMENTS[46250] = Fluid3D([14280,13829,14498,13921],0); -ELEMENTS[46251] = Fluid3D([14068,14471,14982,14796],0); -ELEMENTS[46252] = Fluid3D([18148,18011,17948,17876],0); -ELEMENTS[46253] = Fluid3D([7816,7932,8008,8662],0); -ELEMENTS[46254] = Fluid3D([7932,8008,8662,8853],0); -ELEMENTS[46255] = Fluid3D([7816,7932,8662,8508],0); -ELEMENTS[46256] = Fluid3D([11432,12306,11704,12384],0); -ELEMENTS[46257] = Fluid3D([11432,12306,12384,12465],0); -ELEMENTS[46258] = Fluid3D([8743,8271,9043,9697],0); -ELEMENTS[46259] = Fluid3D([17403,17366,17445,17684],0); -ELEMENTS[46260] = Fluid3D([17445,17403,17684,17298],0); -ELEMENTS[46261] = Fluid3D([17684,17445,17298,17647],0); -ELEMENTS[46262] = Fluid3D([6153,6724,6106,6142],0); -ELEMENTS[46263] = Fluid3D([7112,6964,6372,6532],0); -ELEMENTS[46264] = Fluid3D([14971,14886,14998,14031],0); -ELEMENTS[46265] = Fluid3D([12080,11830,11582,11254],0); -ELEMENTS[46266] = Fluid3D([4113,3654,3810,4203],0); -ELEMENTS[46267] = Fluid3D([3810,4113,4203,4327],0); -ELEMENTS[46268] = Fluid3D([4113,4203,4327,4634],0); -ELEMENTS[46269] = Fluid3D([4113,4203,4634,4483],0); -ELEMENTS[46270] = Fluid3D([4203,4327,4634,4756],0); -ELEMENTS[46271] = Fluid3D([4113,3654,4203,3874],0); -ELEMENTS[46272] = Fluid3D([4634,4113,4483,4383],0); -ELEMENTS[46273] = Fluid3D([4634,4113,4383,4327],0); -ELEMENTS[46274] = Fluid3D([4113,4483,4383,4160],0); -ELEMENTS[46275] = Fluid3D([4483,4634,4383,4427],0); -ELEMENTS[46276] = Fluid3D([4383,4483,4427,4160],0); -ELEMENTS[46277] = Fluid3D([4113,4203,4483,3874],0); -ELEMENTS[46278] = Fluid3D([16193,15988,15669,15346],0); -ELEMENTS[46279] = Fluid3D([10142,10612,11135,10638],0); -ELEMENTS[46280] = Fluid3D([8398,8640,8417,8804],0); -ELEMENTS[46281] = Fluid3D([6996,7178,6646,6450],0); -ELEMENTS[46282] = Fluid3D([12350,11807,12882,12900],0); -ELEMENTS[46283] = Fluid3D([12882,12350,12900,13266],0); -ELEMENTS[46284] = Fluid3D([13318,12913,12023,12627],0); -ELEMENTS[46285] = Fluid3D([14807,14835,15339,15600],0); -ELEMENTS[46286] = Fluid3D([17032,16689,17182,16922],0); -ELEMENTS[46287] = Fluid3D([11715,11330,10916,10373],0); -ELEMENTS[46288] = Fluid3D([11330,10916,10373,10930],0); -ELEMENTS[46289] = Fluid3D([10916,10373,10930,9570],0); -ELEMENTS[46290] = Fluid3D([10916,11715,10373,11218],0); -ELEMENTS[46291] = Fluid3D([10916,10373,9570,9618],0); -ELEMENTS[46292] = Fluid3D([10373,10916,11218,10191],0); -ELEMENTS[46293] = Fluid3D([10373,10916,10191,9618],0); -ELEMENTS[46294] = Fluid3D([2096,2287,2065,2213],0); -ELEMENTS[46295] = Fluid3D([6923,6985,7069,8116],0); -ELEMENTS[46296] = Fluid3D([6980,6374,6237,6354],0); -ELEMENTS[46297] = Fluid3D([6374,6237,6354,5715],0); -ELEMENTS[46298] = Fluid3D([6237,6980,6354,6272],0); -ELEMENTS[46299] = Fluid3D([6354,6237,6272,5578],0); -ELEMENTS[46300] = Fluid3D([6980,6354,6272,6841],0); -ELEMENTS[46301] = Fluid3D([6980,6354,6841,6374],0); -ELEMENTS[46302] = Fluid3D([6354,6272,6841,6363],0); -ELEMENTS[46303] = Fluid3D([6841,6354,6363,6374],0); -ELEMENTS[46304] = Fluid3D([6354,6272,6363,5578],0); -ELEMENTS[46305] = Fluid3D([6354,6363,6374,5715],0); -ELEMENTS[46306] = Fluid3D([6237,6980,6272,6959],0); -ELEMENTS[46307] = Fluid3D([13052,12977,13718,14103],0); -ELEMENTS[46308] = Fluid3D([2210,2413,2256,2142],0); -ELEMENTS[46309] = Fluid3D([2413,2256,2142,2260],0); -ELEMENTS[46310] = Fluid3D([2256,2142,2260,2060],0); -ELEMENTS[46311] = Fluid3D([2260,2256,2060,2171],0); -ELEMENTS[46312] = Fluid3D([2256,2142,2060,2061],0); -ELEMENTS[46313] = Fluid3D([2256,2142,2061,2210],0); -ELEMENTS[46314] = Fluid3D([2061,2256,2210,2326],0); -ELEMENTS[46315] = Fluid3D([2142,2061,2210,1938],0); -ELEMENTS[46316] = Fluid3D([2060,2256,2061,2171],0); -ELEMENTS[46317] = Fluid3D([2061,2210,1938,2032],0); -ELEMENTS[46318] = Fluid3D([2142,2060,2061,1931],0); -ELEMENTS[46319] = Fluid3D([2142,2260,2060,2080],0); -ELEMENTS[46320] = Fluid3D([14422,14014,13610,14063],0); -ELEMENTS[46321] = Fluid3D([14014,13610,14063,14445],0); -ELEMENTS[46322] = Fluid3D([13610,14422,14063,13578],0); -ELEMENTS[46323] = Fluid3D([14063,13610,13578,13565],0); -ELEMENTS[46324] = Fluid3D([14063,13610,13565,13349],0); -ELEMENTS[46325] = Fluid3D([3631,3812,4089,4071],0); -ELEMENTS[46326] = Fluid3D([12888,11844,13119,12515],0); -ELEMENTS[46327] = Fluid3D([16552,16614,17019,16723],0); -ELEMENTS[46328] = Fluid3D([13345,12647,13141,13876],0); -ELEMENTS[46329] = Fluid3D([13141,13345,13876,13046],0); -ELEMENTS[46330] = Fluid3D([18257,18093,17965,18090],0); -ELEMENTS[46331] = Fluid3D([17965,18257,18090,18198],0); -ELEMENTS[46332] = Fluid3D([10200,10764,11442,10110],0); -ELEMENTS[46333] = Fluid3D([17091,16624,16868,17053],0); -ELEMENTS[46334] = Fluid3D([4209,4699,3983,4426],0); -ELEMENTS[46335] = Fluid3D([11934,12733,12459,13297],0); -ELEMENTS[46336] = Fluid3D([6104,5974,6212,6838],0); -ELEMENTS[46337] = Fluid3D([5159,4940,4948,4604],0); -ELEMENTS[46338] = Fluid3D([12109,11324,11879,11335],0); -ELEMENTS[46339] = Fluid3D([11879,12109,11335,11988],0); -ELEMENTS[46340] = Fluid3D([12109,11335,11988,11411],0); -ELEMENTS[46341] = Fluid3D([11335,11988,11411,10806],0); -ELEMENTS[46342] = Fluid3D([12109,11324,11335,11525],0); -ELEMENTS[46343] = Fluid3D([11411,11335,10806,10493],0); -ELEMENTS[46344] = Fluid3D([11335,10806,10493,11148],0); -ELEMENTS[46345] = Fluid3D([11411,11335,10493,10624],0); -ELEMENTS[46346] = Fluid3D([11335,10493,10624,11324],0); -ELEMENTS[46347] = Fluid3D([2741,2403,2460,2365],0); -ELEMENTS[46348] = Fluid3D([9853,10493,9677,10624],0); -ELEMENTS[46349] = Fluid3D([9853,10493,10624,11411],0); -ELEMENTS[46350] = Fluid3D([10660,11686,10912,11168],0); -ELEMENTS[46351] = Fluid3D([13530,13229,13598,14381],0); -ELEMENTS[46352] = Fluid3D([3777,4030,4175,3569],0); -ELEMENTS[46353] = Fluid3D([5828,5818,5398,6308],0); -ELEMENTS[46354] = Fluid3D([17531,17104,17326,17400],0); -ELEMENTS[46355] = Fluid3D([17326,17531,17400,17776],0); -ELEMENTS[46356] = Fluid3D([17104,17326,17400,16968],0); -ELEMENTS[46357] = Fluid3D([17326,17400,16968,17675],0); -ELEMENTS[46358] = Fluid3D([15329,15237,14996,15526],0); -ELEMENTS[46359] = Fluid3D([6204,6200,6198,5442],0); -ELEMENTS[46360] = Fluid3D([13826,14258,13435,13316],0); -ELEMENTS[46361] = Fluid3D([14258,13435,13316,13681],0); -ELEMENTS[46362] = Fluid3D([13435,13316,13681,12888],0); -ELEMENTS[46363] = Fluid3D([4528,4164,4711,4068],0); -ELEMENTS[46364] = Fluid3D([4528,4164,4068,3900],0); -ELEMENTS[46365] = Fluid3D([4164,4711,4068,4243],0); -ELEMENTS[46366] = Fluid3D([4068,4164,4243,3851],0); -ELEMENTS[46367] = Fluid3D([4068,4164,3851,3843],0); -ELEMENTS[46368] = Fluid3D([4068,4164,3843,3900],0); -ELEMENTS[46369] = Fluid3D([14343,14309,15057,14665],0); -ELEMENTS[46370] = Fluid3D([17143,17090,17298,16832],0); -ELEMENTS[46371] = Fluid3D([17298,17143,16832,16944],0); -ELEMENTS[46372] = Fluid3D([18192,17999,18132,17933],0); -ELEMENTS[46373] = Fluid3D([2379,2512,2340,2581],0); -ELEMENTS[46374] = Fluid3D([14395,14883,14785,14946],0); -ELEMENTS[46375] = Fluid3D([8466,8120,7525,7726],0); -ELEMENTS[46376] = Fluid3D([7525,8466,7726,8143],0); -ELEMENTS[46377] = Fluid3D([7726,7525,8143,7348],0); -ELEMENTS[46378] = Fluid3D([7726,7525,7348,6822],0); -ELEMENTS[46379] = Fluid3D([8120,7525,7726,7320],0); -ELEMENTS[46380] = Fluid3D([8143,7726,7348,7213],0); -ELEMENTS[46381] = Fluid3D([7525,8143,7348,7701],0); -ELEMENTS[46382] = Fluid3D([7348,7525,7701,6822],0); -ELEMENTS[46383] = Fluid3D([7525,7726,7320,6949],0); -ELEMENTS[46384] = Fluid3D([7525,7726,6949,6822],0); -ELEMENTS[46385] = Fluid3D([7421,7505,8067,7241],0); -ELEMENTS[46386] = Fluid3D([5772,6186,5356,5775],0); -ELEMENTS[46387] = Fluid3D([5970,6875,6067,6590],0); -ELEMENTS[46388] = Fluid3D([15509,15336,15648,15209],0); -ELEMENTS[46389] = Fluid3D([15509,15336,15209,14920],0); -ELEMENTS[46390] = Fluid3D([15209,15509,14920,15749],0); -ELEMENTS[46391] = Fluid3D([15209,15509,15749,15648],0); -ELEMENTS[46392] = Fluid3D([15508,15574,15184,14801],0); -ELEMENTS[46393] = Fluid3D([17129,17496,17357,17200],0); -ELEMENTS[46394] = Fluid3D([17129,17496,17200,17361],0); -ELEMENTS[46395] = Fluid3D([17200,17129,17361,17043],0); -ELEMENTS[46396] = Fluid3D([17129,17496,17361,17198],0); -ELEMENTS[46397] = Fluid3D([17357,17129,17200,16981],0); -ELEMENTS[46398] = Fluid3D([2402,2542,2714,2667],0); -ELEMENTS[46399] = Fluid3D([2542,2714,2667,2914],0); -ELEMENTS[46400] = Fluid3D([2402,2542,2667,2511],0); -ELEMENTS[46401] = Fluid3D([2714,2667,2914,2751],0); -ELEMENTS[46402] = Fluid3D([2667,2542,2914,2844],0); -ELEMENTS[46403] = Fluid3D([2667,2914,2751,2957],0); -ELEMENTS[46404] = Fluid3D([2751,2667,2957,2511],0); -ELEMENTS[46405] = Fluid3D([2667,2914,2957,2738],0); -ELEMENTS[46406] = Fluid3D([2751,2667,2511,2402],0); -ELEMENTS[46407] = Fluid3D([12267,11747,11772,11613],0); -ELEMENTS[46408] = Fluid3D([14491,14147,14075,13633],0); -ELEMENTS[46409] = Fluid3D([4253,4862,4783,4436],0); -ELEMENTS[46410] = Fluid3D([4783,4253,4436,4222],0); -ELEMENTS[46411] = Fluid3D([4253,4436,4222,4019],0); -ELEMENTS[46412] = Fluid3D([4253,4436,4019,4370],0); -ELEMENTS[46413] = Fluid3D([4019,4253,4370,3970],0); -ELEMENTS[46414] = Fluid3D([4019,4253,3970,3630],0); -ELEMENTS[46415] = Fluid3D([4370,4019,3970,4069],0); -ELEMENTS[46416] = Fluid3D([4253,4370,3970,4802],0); -ELEMENTS[46417] = Fluid3D([4253,4436,4370,4802],0); -ELEMENTS[46418] = Fluid3D([4436,4019,4370,4069],0); -ELEMENTS[46419] = Fluid3D([4222,4253,4019,3815],0); -ELEMENTS[46420] = Fluid3D([3970,4370,4069,4064],0); -ELEMENTS[46421] = Fluid3D([4436,4222,4019,3723],0); -ELEMENTS[46422] = Fluid3D([4436,4783,4222,4352],0); -ELEMENTS[46423] = Fluid3D([4370,4069,4064,4772],0); -ELEMENTS[46424] = Fluid3D([4370,4069,4772,4755],0); -ELEMENTS[46425] = Fluid3D([4772,4370,4755,4436],0); -ELEMENTS[46426] = Fluid3D([3970,4370,4064,4802],0); -ELEMENTS[46427] = Fluid3D([4772,4370,4436,4802],0); -ELEMENTS[46428] = Fluid3D([4772,4370,4802,4064],0); -ELEMENTS[46429] = Fluid3D([4222,4436,4352,3723],0); -ELEMENTS[46430] = Fluid3D([4370,4755,4436,4069],0); -ELEMENTS[46431] = Fluid3D([4019,3970,4069,3658],0); -ELEMENTS[46432] = Fluid3D([4019,3970,3658,3584],0); -ELEMENTS[46433] = Fluid3D([4019,3970,3584,3630],0); -ELEMENTS[46434] = Fluid3D([3584,4019,3630,3815],0); -ELEMENTS[46435] = Fluid3D([3630,3584,3815,3407],0); -ELEMENTS[46436] = Fluid3D([3630,3584,3407,3235],0); -ELEMENTS[46437] = Fluid3D([3630,3584,3235,3459],0); -ELEMENTS[46438] = Fluid3D([3584,3407,3235,3274],0); -ELEMENTS[46439] = Fluid3D([3584,3407,3274,3723],0); -ELEMENTS[46440] = Fluid3D([3584,3407,3723,3815],0); -ELEMENTS[46441] = Fluid3D([3407,3274,3723,3192],0); -ELEMENTS[46442] = Fluid3D([3407,3274,3192,3031],0); -ELEMENTS[46443] = Fluid3D([3407,3274,3031,3235],0); -ELEMENTS[46444] = Fluid3D([3274,3192,3031,2853],0); -ELEMENTS[46445] = Fluid3D([3274,3031,3235,3259],0); -ELEMENTS[46446] = Fluid3D([3274,3031,3259,2961],0); -ELEMENTS[46447] = Fluid3D([3274,3031,2961,2853],0); -ELEMENTS[46448] = Fluid3D([3970,3584,3630,3795],0); -ELEMENTS[46449] = Fluid3D([3031,3259,2961,2880],0); -ELEMENTS[46450] = Fluid3D([2961,3031,2880,2719],0); -ELEMENTS[46451] = Fluid3D([2961,3031,2719,2853],0); -ELEMENTS[46452] = Fluid3D([2880,2961,2719,2590],0); -ELEMENTS[46453] = Fluid3D([3259,2961,2880,3128],0); -ELEMENTS[46454] = Fluid3D([2719,2961,2853,2788],0); -ELEMENTS[46455] = Fluid3D([2719,2961,2788,2590],0); -ELEMENTS[46456] = Fluid3D([3630,3584,3459,3795],0); -ELEMENTS[46457] = Fluid3D([3514,3788,3375,3438],0); -ELEMENTS[46458] = Fluid3D([3514,3788,3438,3863],0); -ELEMENTS[46459] = Fluid3D([3375,3514,3438,3075],0); -ELEMENTS[46460] = Fluid3D([3788,3375,3438,3882],0); -ELEMENTS[46461] = Fluid3D([14780,14301,14578,13907],0); -ELEMENTS[46462] = Fluid3D([18271,18282,18088,18143],0); -ELEMENTS[46463] = Fluid3D([10860,11207,12156,11240],0); -ELEMENTS[46464] = Fluid3D([1956,1915,2083,2010],0); -ELEMENTS[46465] = Fluid3D([2083,1956,2010,2098],0); -ELEMENTS[46466] = Fluid3D([1956,1915,2010,1880],0); -ELEMENTS[46467] = Fluid3D([2010,1956,1880,2098],0); -ELEMENTS[46468] = Fluid3D([1915,2010,1880,1878],0); -ELEMENTS[46469] = Fluid3D([2010,1880,1878,2087],0); -ELEMENTS[46470] = Fluid3D([7769,7978,7169,6841],0); -ELEMENTS[46471] = Fluid3D([8207,8846,8072,7791],0); -ELEMENTS[46472] = Fluid3D([4956,4690,4851,5369],0); -ELEMENTS[46473] = Fluid3D([16266,16498,16608,16997],0); -ELEMENTS[46474] = Fluid3D([11422,10514,11735,11287],0); -ELEMENTS[46475] = Fluid3D([6483,6978,7119,6181],0); -ELEMENTS[46476] = Fluid3D([9130,8990,8547,9475],0); -ELEMENTS[46477] = Fluid3D([8990,8547,9475,8428],0); -ELEMENTS[46478] = Fluid3D([9020,8517,8201,8332],0); -ELEMENTS[46479] = Fluid3D([8517,8201,8332,7813],0); -ELEMENTS[46480] = Fluid3D([8201,8332,7813,7478],0); -ELEMENTS[46481] = Fluid3D([8332,8517,7813,7853],0); -ELEMENTS[46482] = Fluid3D([8517,8201,7813,8569],0); -ELEMENTS[46483] = Fluid3D([7813,8201,7478,8569],0); -ELEMENTS[46484] = Fluid3D([8201,9020,8332,8374],0); -ELEMENTS[46485] = Fluid3D([8332,8201,8374,7652],0); -ELEMENTS[46486] = Fluid3D([8332,8201,7652,7478],0); -ELEMENTS[46487] = Fluid3D([7813,8332,7853,7161],0); -ELEMENTS[46488] = Fluid3D([4896,4527,4775,4935],0); -ELEMENTS[46489] = Fluid3D([6589,6956,6321,6543],0); -ELEMENTS[46490] = Fluid3D([15402,15998,15477,15805],0); -ELEMENTS[46491] = Fluid3D([15402,15998,15805,15761],0); -ELEMENTS[46492] = Fluid3D([16066,15644,15490,15081],0); -ELEMENTS[46493] = Fluid3D([15644,15490,15081,15312],0); -ELEMENTS[46494] = Fluid3D([6585,7022,7406,7217],0); -ELEMENTS[46495] = Fluid3D([16485,16139,16595,16542],0); -ELEMENTS[46496] = Fluid3D([13012,12911,13459,12740],0); -ELEMENTS[46497] = Fluid3D([12911,13459,12740,13022],0); -ELEMENTS[46498] = Fluid3D([13459,13012,12740,13127],0); -ELEMENTS[46499] = Fluid3D([12740,13459,13127,13362],0); -ELEMENTS[46500] = Fluid3D([12740,13459,13362,13022],0); -ELEMENTS[46501] = Fluid3D([13362,12740,13022,13279],0); -ELEMENTS[46502] = Fluid3D([13022,13362,13279,13470],0); -ELEMENTS[46503] = Fluid3D([13127,12740,13362,13279],0); -ELEMENTS[46504] = Fluid3D([13459,13362,13022,13902],0); -ELEMENTS[46505] = Fluid3D([13362,13022,13902,13470],0); -ELEMENTS[46506] = Fluid3D([13459,13362,13902,14121],0); -ELEMENTS[46507] = Fluid3D([13902,13459,14121,13956],0); -ELEMENTS[46508] = Fluid3D([13459,14121,13956,13620],0); -ELEMENTS[46509] = Fluid3D([13459,14121,13620,13796],0); -ELEMENTS[46510] = Fluid3D([13902,13459,13956,13532],0); -ELEMENTS[46511] = Fluid3D([13956,13902,13532,14306],0); -ELEMENTS[46512] = Fluid3D([13532,13956,14306,13824],0); -ELEMENTS[46513] = Fluid3D([13532,13956,13824,13466],0); -ELEMENTS[46514] = Fluid3D([14306,13532,13824,14189],0); -ELEMENTS[46515] = Fluid3D([13956,13902,14306,14442],0); -ELEMENTS[46516] = Fluid3D([13956,13902,14442,14121],0); -ELEMENTS[46517] = Fluid3D([13902,14306,14442,14792],0); -ELEMENTS[46518] = Fluid3D([13902,14442,14121,14605],0); -ELEMENTS[46519] = Fluid3D([13902,13532,14306,13683],0); -ELEMENTS[46520] = Fluid3D([13532,14306,13683,14189],0); -ELEMENTS[46521] = Fluid3D([14442,13902,14792,14166],0); -ELEMENTS[46522] = Fluid3D([13824,13532,13466,12664],0); -ELEMENTS[46523] = Fluid3D([16065,16324,16116,15828],0); -ELEMENTS[46524] = Fluid3D([13105,12827,13531,13054],0); -ELEMENTS[46525] = Fluid3D([12827,13531,13054,13469],0); -ELEMENTS[46526] = Fluid3D([12827,13531,13469,13931],0); -ELEMENTS[46527] = Fluid3D([8068,7925,7745,8858],0); -ELEMENTS[46528] = Fluid3D([8068,7925,8858,8639],0); -ELEMENTS[46529] = Fluid3D([4640,4758,5125,4560],0); -ELEMENTS[46530] = Fluid3D([5125,4640,4560,5072],0); -ELEMENTS[46531] = Fluid3D([4560,5125,5072,4985],0); -ELEMENTS[46532] = Fluid3D([5125,4640,5072,5224],0); -ELEMENTS[46533] = Fluid3D([9383,10438,9786,9563],0); -ELEMENTS[46534] = Fluid3D([8951,9097,9368,8478],0); -ELEMENTS[46535] = Fluid3D([9368,8951,8478,8332],0); -ELEMENTS[46536] = Fluid3D([8951,9097,8478,8089],0); -ELEMENTS[46537] = Fluid3D([8951,8478,8332,7652],0); -ELEMENTS[46538] = Fluid3D([9097,8478,8089,8794],0); -ELEMENTS[46539] = Fluid3D([16600,16744,16108,16336],0); -ELEMENTS[46540] = Fluid3D([9171,10054,9610,9127],0); -ELEMENTS[46541] = Fluid3D([9610,9171,9127,8432],0); -ELEMENTS[46542] = Fluid3D([15053,14275,14581,14717],0); -ELEMENTS[46543] = Fluid3D([16318,16150,16273,16646],0); -ELEMENTS[46544] = Fluid3D([16273,16318,16646,16197],0); -ELEMENTS[46545] = Fluid3D([13542,13350,14180,14049],0); -ELEMENTS[46546] = Fluid3D([4100,3725,4138,3830],0); -ELEMENTS[46547] = Fluid3D([15174,15051,15592,15305],0); -ELEMENTS[46548] = Fluid3D([14261,14161,14726,15185],0); -ELEMENTS[46549] = Fluid3D([5056,5664,5552,5342],0); -ELEMENTS[46550] = Fluid3D([13489,12990,12675,12524],0); -ELEMENTS[46551] = Fluid3D([12990,12675,12524,11950],0); -ELEMENTS[46552] = Fluid3D([15214,15605,15762,15904],0); -ELEMENTS[46553] = Fluid3D([5649,5241,5834,5840],0); -ELEMENTS[46554] = Fluid3D([5241,5834,5840,5428],0); -ELEMENTS[46555] = Fluid3D([5834,5649,5840,6266],0); -ELEMENTS[46556] = Fluid3D([5834,5840,5428,6639],0); -ELEMENTS[46557] = Fluid3D([5834,5840,6639,6266],0); -ELEMENTS[46558] = Fluid3D([5725,6066,5971,6460],0); -ELEMENTS[46559] = Fluid3D([6810,5926,6337,5885],0); -ELEMENTS[46560] = Fluid3D([5926,6337,5885,5756],0); -ELEMENTS[46561] = Fluid3D([11346,11039,12160,12191],0); -ELEMENTS[46562] = Fluid3D([14196,13933,13614,13028],0); -ELEMENTS[46563] = Fluid3D([13933,13614,13028,12657],0); -ELEMENTS[46564] = Fluid3D([13614,13028,12657,12403],0); -ELEMENTS[46565] = Fluid3D([16964,17185,17243,17008],0); -ELEMENTS[46566] = Fluid3D([17243,16964,17008,16968],0); -ELEMENTS[46567] = Fluid3D([8333,9009,8816,9463],0); -ELEMENTS[46568] = Fluid3D([10754,9934,10228,9886],0); -ELEMENTS[46569] = Fluid3D([5228,4644,5139,4977],0); -ELEMENTS[46570] = Fluid3D([9288,9203,10359,9722],0); -ELEMENTS[46571] = Fluid3D([9288,9203,9722,9039],0); -ELEMENTS[46572] = Fluid3D([9203,10359,9722,9882],0); -ELEMENTS[46573] = Fluid3D([9722,9203,9882,9039],0); -ELEMENTS[46574] = Fluid3D([10359,9722,9882,11091],0); -ELEMENTS[46575] = Fluid3D([9882,9722,9039,9816],0); -ELEMENTS[46576] = Fluid3D([15064,14531,15261,14934],0); -ELEMENTS[46577] = Fluid3D([9664,10338,9885,10264],0); -ELEMENTS[46578] = Fluid3D([10429,9572,10026,10553],0); -ELEMENTS[46579] = Fluid3D([10026,10429,10553,11057],0); -ELEMENTS[46580] = Fluid3D([14541,14229,15073,14115],0); -ELEMENTS[46581] = Fluid3D([4638,5237,5195,4832],0); -ELEMENTS[46582] = Fluid3D([2143,1977,2037,2258],0); -ELEMENTS[46583] = Fluid3D([15958,16118,16393,16462],0); -ELEMENTS[46584] = Fluid3D([9833,9395,9819,10618],0); -ELEMENTS[46585] = Fluid3D([17834,18005,17751,18066],0); -ELEMENTS[46586] = Fluid3D([6307,5983,5905,6287],0); -ELEMENTS[46587] = Fluid3D([10436,10791,11171,9723],0); -ELEMENTS[46588] = Fluid3D([12344,12417,13333,12673],0); -ELEMENTS[46589] = Fluid3D([18329,18383,18173,18143],0); -ELEMENTS[46590] = Fluid3D([18383,18173,18143,18271],0); -ELEMENTS[46591] = Fluid3D([18383,18173,18271,18097],0); -ELEMENTS[46592] = Fluid3D([18173,18271,18097,18143],0); -ELEMENTS[46593] = Fluid3D([18097,18173,18143,17876],0); -ELEMENTS[46594] = Fluid3D([18173,18329,18143,18148],0); -ELEMENTS[46595] = Fluid3D([18143,18173,18148,17876],0); -ELEMENTS[46596] = Fluid3D([18173,18329,18148,17876],0); -ELEMENTS[46597] = Fluid3D([18097,18173,17876,18329],0); -ELEMENTS[46598] = Fluid3D([11442,12435,11813,12010],0); -ELEMENTS[46599] = Fluid3D([9956,9935,10553,10552],0); -ELEMENTS[46600] = Fluid3D([5164,4693,5258,5109],0); -ELEMENTS[46601] = Fluid3D([10896,11604,11609,11367],0); -ELEMENTS[46602] = Fluid3D([13630,14145,14199,13570],0); -ELEMENTS[46603] = Fluid3D([13630,14145,13570,12808],0); -ELEMENTS[46604] = Fluid3D([14199,13630,13570,12808],0); -ELEMENTS[46605] = Fluid3D([14334,13546,14216,13921],0); -ELEMENTS[46606] = Fluid3D([13649,13040,13707,12732],0); -ELEMENTS[46607] = Fluid3D([2318,2514,2471,2365],0); -ELEMENTS[46608] = Fluid3D([2514,2471,2365,2744],0); -ELEMENTS[46609] = Fluid3D([2514,2471,2744,2872],0); -ELEMENTS[46610] = Fluid3D([13406,13441,13896,14443],0); -ELEMENTS[46611] = Fluid3D([8342,9069,8811,8170],0); -ELEMENTS[46612] = Fluid3D([4209,3983,3950,4386],0); -ELEMENTS[46613] = Fluid3D([4209,3983,4386,4426],0); -ELEMENTS[46614] = Fluid3D([3950,4209,4386,4363],0); -ELEMENTS[46615] = Fluid3D([15444,15213,15794,15492],0); -ELEMENTS[46616] = Fluid3D([18477,18366,18531,18298],0); -ELEMENTS[46617] = Fluid3D([8863,8360,9157,9352],0); -ELEMENTS[46618] = Fluid3D([9295,8758,9148,9470],0); -ELEMENTS[46619] = Fluid3D([8758,9148,9470,8765],0); -ELEMENTS[46620] = Fluid3D([9295,8758,9470,9812],0); -ELEMENTS[46621] = Fluid3D([8758,9470,9812,8860],0); -ELEMENTS[46622] = Fluid3D([8758,9470,8860,8765],0); -ELEMENTS[46623] = Fluid3D([14848,15147,15350,14535],0); -ELEMENTS[46624] = Fluid3D([10180,10728,11201,11436],0); -ELEMENTS[46625] = Fluid3D([10728,11201,11436,11023],0); -ELEMENTS[46626] = Fluid3D([10728,11201,11023,10475],0); -ELEMENTS[46627] = Fluid3D([11436,10728,11023,10797],0); -ELEMENTS[46628] = Fluid3D([11023,10728,10475,10319],0); -ELEMENTS[46629] = Fluid3D([11020,10399,11105,9781],0); -ELEMENTS[46630] = Fluid3D([7512,7272,7024,7832],0); -ELEMENTS[46631] = Fluid3D([7024,7512,7832,8054],0); -ELEMENTS[46632] = Fluid3D([15936,15909,15836,16368],0); -ELEMENTS[46633] = Fluid3D([12772,13224,12957,12389],0); -ELEMENTS[46634] = Fluid3D([17351,17669,17386,17486],0); -ELEMENTS[46635] = Fluid3D([17351,17669,17486,17757],0); -ELEMENTS[46636] = Fluid3D([13052,13718,13666,13691],0); -ELEMENTS[46637] = Fluid3D([16091,15475,15681,15894],0); -ELEMENTS[46638] = Fluid3D([15475,15681,15894,15469],0); -ELEMENTS[46639] = Fluid3D([16091,15475,15894,16291],0); -ELEMENTS[46640] = Fluid3D([5335,5152,5583,4731],0); -ELEMENTS[46641] = Fluid3D([12317,11459,11812,12318],0); -ELEMENTS[46642] = Fluid3D([11459,11812,12318,10943],0); -ELEMENTS[46643] = Fluid3D([15038,15525,15708,15894],0); -ELEMENTS[46644] = Fluid3D([15525,15708,15894,16111],0); -ELEMENTS[46645] = Fluid3D([15525,15708,16111,15932],0); -ELEMENTS[46646] = Fluid3D([15894,15525,16111,16291],0); -ELEMENTS[46647] = Fluid3D([17603,17520,17485,17174],0); -ELEMENTS[46648] = Fluid3D([13419,14024,13627,14353],0); -ELEMENTS[46649] = Fluid3D([14024,13627,14353,13851],0); -ELEMENTS[46650] = Fluid3D([14809,14592,14664,15146],0); -ELEMENTS[46651] = Fluid3D([8321,8502,8067,7487],0); -ELEMENTS[46652] = Fluid3D([9637,10149,9427,9247],0); -ELEMENTS[46653] = Fluid3D([2528,2578,2433,2264],0); -ELEMENTS[46654] = Fluid3D([14034,14524,14312,14852],0); -ELEMENTS[46655] = Fluid3D([14312,14034,14852,14378],0); -ELEMENTS[46656] = Fluid3D([14524,14312,14852,14769],0); -ELEMENTS[46657] = Fluid3D([14312,14852,14769,14874],0); -ELEMENTS[46658] = Fluid3D([14769,14312,14874,14131],0); -ELEMENTS[46659] = Fluid3D([14874,14769,14131,14397],0); -ELEMENTS[46660] = Fluid3D([14769,14312,14131,14066],0); -ELEMENTS[46661] = Fluid3D([14312,14874,14131,13877],0); -ELEMENTS[46662] = Fluid3D([14312,14131,14066,13634],0); -ELEMENTS[46663] = Fluid3D([5590,5225,5595,5969],0); -ELEMENTS[46664] = Fluid3D([15076,14803,14257,15193],0); -ELEMENTS[46665] = Fluid3D([16925,17183,17339,17105],0); -ELEMENTS[46666] = Fluid3D([16130,16177,16180,16766],0); -ELEMENTS[46667] = Fluid3D([10487,10398,10020,9392],0); -ELEMENTS[46668] = Fluid3D([13934,14400,14658,13806],0); -ELEMENTS[46669] = Fluid3D([14657,13787,14738,13915],0); -ELEMENTS[46670] = Fluid3D([7724,8180,7814,7477],0); -ELEMENTS[46671] = Fluid3D([8365,8406,7966,7488],0); -ELEMENTS[46672] = Fluid3D([15254,15099,14322,14462],0); -ELEMENTS[46673] = Fluid3D([2577,2387,2423,2609],0); -ELEMENTS[46674] = Fluid3D([17444,17082,17434,17019],0); -ELEMENTS[46675] = Fluid3D([17444,17082,17019,17066],0); -ELEMENTS[46676] = Fluid3D([17444,17082,17066,17173],0); -ELEMENTS[46677] = Fluid3D([17082,17019,17066,16614],0); -ELEMENTS[46678] = Fluid3D([17973,17730,17726,17849],0); -ELEMENTS[46679] = Fluid3D([17973,17730,17849,18070],0); -ELEMENTS[46680] = Fluid3D([17730,17726,17849,17407],0); -ELEMENTS[46681] = Fluid3D([14994,14934,14363,15370],0); -ELEMENTS[46682] = Fluid3D([14994,14934,15370,15882],0); -ELEMENTS[46683] = Fluid3D([14841,14526,14911,15266],0); -ELEMENTS[46684] = Fluid3D([14841,14526,15266,15207],0); -ELEMENTS[46685] = Fluid3D([5453,5063,5200,5559],0); -ELEMENTS[46686] = Fluid3D([5063,5200,5559,4753],0); -ELEMENTS[46687] = Fluid3D([5453,5063,5559,4996],0); -ELEMENTS[46688] = Fluid3D([5559,5063,4753,5089],0); -ELEMENTS[46689] = Fluid3D([8465,8212,7934,7728],0); -ELEMENTS[46690] = Fluid3D([2346,2463,2312,2106],0); -ELEMENTS[46691] = Fluid3D([8797,9683,9692,8576],0); -ELEMENTS[46692] = Fluid3D([7225,7872,7728,6923],0); -ELEMENTS[46693] = Fluid3D([2386,2541,2419,2379],0); -ELEMENTS[46694] = Fluid3D([14393,13585,13758,13575],0); -ELEMENTS[46695] = Fluid3D([13585,13758,13575,12468],0); -ELEMENTS[46696] = Fluid3D([9156,9430,8424,8382],0); -ELEMENTS[46697] = Fluid3D([5670,5819,6311,6017],0); -ELEMENTS[46698] = Fluid3D([6311,5670,6017,6209],0); -ELEMENTS[46699] = Fluid3D([15843,15893,15643,16311],0); -ELEMENTS[46700] = Fluid3D([6046,6347,6442,6765],0); -ELEMENTS[46701] = Fluid3D([15198,14958,15595,15262],0); -ELEMENTS[46702] = Fluid3D([4850,4752,5031,4314],0); -ELEMENTS[46703] = Fluid3D([16345,16473,16662,17039],0); -ELEMENTS[46704] = Fluid3D([7851,8247,8721,8441],0); -ELEMENTS[46705] = Fluid3D([14322,13861,14569,14140],0); -ELEMENTS[46706] = Fluid3D([13577,13174,12929,13913],0); -ELEMENTS[46707] = Fluid3D([13944,14226,14032,14685],0); -ELEMENTS[46708] = Fluid3D([6174,6014,6362,7113],0); -ELEMENTS[46709] = Fluid3D([6014,6362,7113,7106],0); -ELEMENTS[46710] = Fluid3D([12997,13062,13516,13752],0); -ELEMENTS[46711] = Fluid3D([4025,4343,4429,4679],0); -ELEMENTS[46712] = Fluid3D([4343,4429,4679,4797],0); -ELEMENTS[46713] = Fluid3D([16493,16758,16218,16190],0); -ELEMENTS[46714] = Fluid3D([5650,5159,4876,5146],0); -ELEMENTS[46715] = Fluid3D([9959,10419,10594,9893],0); -ELEMENTS[46716] = Fluid3D([10943,10725,10642,11665],0); -ELEMENTS[46717] = Fluid3D([13792,13271,12736,13030],0); -ELEMENTS[46718] = Fluid3D([13271,12736,13030,12128],0); -ELEMENTS[46719] = Fluid3D([12736,13030,12128,12745],0); -ELEMENTS[46720] = Fluid3D([12736,13030,12745,13825],0); -ELEMENTS[46721] = Fluid3D([12736,13792,13030,13825],0); -ELEMENTS[46722] = Fluid3D([4375,4184,3878,3820],0); -ELEMENTS[46723] = Fluid3D([11704,11776,11432,12384],0); -ELEMENTS[46724] = Fluid3D([14650,15103,14490,14932],0); -ELEMENTS[46725] = Fluid3D([15103,14490,14932,15337],0); -ELEMENTS[46726] = Fluid3D([12788,12669,12872,11927],0); -ELEMENTS[46727] = Fluid3D([14939,15473,14779,15163],0); -ELEMENTS[46728] = Fluid3D([8688,9480,9903,9045],0); -ELEMENTS[46729] = Fluid3D([18373,18295,18355,18158],0); -ELEMENTS[46730] = Fluid3D([7064,7640,7672,7056],0); -ELEMENTS[46731] = Fluid3D([2420,2283,2606,2261],0); -ELEMENTS[46732] = Fluid3D([13159,13672,14179,13023],0); -ELEMENTS[46733] = Fluid3D([14466,14199,14612,13757],0); -ELEMENTS[46734] = Fluid3D([14466,14199,13757,13769],0); -ELEMENTS[46735] = Fluid3D([14199,13757,13769,12808],0); -ELEMENTS[46736] = Fluid3D([14199,14612,13757,13849],0); -ELEMENTS[46737] = Fluid3D([13757,14199,13849,13570],0); -ELEMENTS[46738] = Fluid3D([13849,13757,13570,13396],0); -ELEMENTS[46739] = Fluid3D([13757,13570,13396,12808],0); -ELEMENTS[46740] = Fluid3D([13757,13570,12808,14199],0); -ELEMENTS[46741] = Fluid3D([13570,13849,13396,13226],0); -ELEMENTS[46742] = Fluid3D([13570,13849,13226,14145],0); -ELEMENTS[46743] = Fluid3D([13570,13849,14145,14199],0); -ELEMENTS[46744] = Fluid3D([13849,13226,14145,14212],0); -ELEMENTS[46745] = Fluid3D([13396,13570,13226,12808],0); -ELEMENTS[46746] = Fluid3D([13849,13396,13226,13828],0); -ELEMENTS[46747] = Fluid3D([13396,13226,13828,13098],0); -ELEMENTS[46748] = Fluid3D([13396,13226,13098,12808],0); -ELEMENTS[46749] = Fluid3D([13849,14145,14199,14612],0); -ELEMENTS[46750] = Fluid3D([13570,13226,12808,14145],0); -ELEMENTS[46751] = Fluid3D([13226,13849,13828,14212],0); -ELEMENTS[46752] = Fluid3D([13828,13396,13098,13952],0); -ELEMENTS[46753] = Fluid3D([13849,13396,13828,13823],0); -ELEMENTS[46754] = Fluid3D([13849,13757,13396,13823],0); -ELEMENTS[46755] = Fluid3D([13757,13396,13823,12850],0); -ELEMENTS[46756] = Fluid3D([13098,13396,12808,12850],0); -ELEMENTS[46757] = Fluid3D([13098,13396,12850,13823],0); -ELEMENTS[46758] = Fluid3D([13098,13396,13823,13952],0); -ELEMENTS[46759] = Fluid3D([13849,14145,14612,14212],0); -ELEMENTS[46760] = Fluid3D([13828,13226,14212,13344],0); -ELEMENTS[46761] = Fluid3D([14212,13828,13344,13835],0); -ELEMENTS[46762] = Fluid3D([14212,13828,13835,14459],0); -ELEMENTS[46763] = Fluid3D([13828,13835,14459,14612],0); -ELEMENTS[46764] = Fluid3D([13835,14212,14459,13635],0); -ELEMENTS[46765] = Fluid3D([14459,13835,13635,13916],0); -ELEMENTS[46766] = Fluid3D([13835,14212,13635,13344],0); -ELEMENTS[46767] = Fluid3D([13835,13635,13916,13108],0); -ELEMENTS[46768] = Fluid3D([13835,13635,13108,12708],0); -ELEMENTS[46769] = Fluid3D([14212,13828,14459,14612],0); -ELEMENTS[46770] = Fluid3D([13635,13835,13344,12708],0); -ELEMENTS[46771] = Fluid3D([13849,13828,14212,14612],0); -ELEMENTS[46772] = Fluid3D([13635,13916,13108,13056],0); -ELEMENTS[46773] = Fluid3D([13108,13635,13056,12743],0); -ELEMENTS[46774] = Fluid3D([13916,13108,13056,13360],0); -ELEMENTS[46775] = Fluid3D([9171,9127,8432,8261],0); -ELEMENTS[46776] = Fluid3D([9171,9127,8261,8988],0); -ELEMENTS[46777] = Fluid3D([9171,9127,8988,10271],0); -ELEMENTS[46778] = Fluid3D([8261,9171,8988,8710],0); -ELEMENTS[46779] = Fluid3D([8261,9171,8710,8426],0); -ELEMENTS[46780] = Fluid3D([9171,8988,8710,9663],0); -ELEMENTS[46781] = Fluid3D([8710,9171,9663,9527],0); -ELEMENTS[46782] = Fluid3D([9171,9663,9527,10271],0); -ELEMENTS[46783] = Fluid3D([9171,9663,10271,8988],0); -ELEMENTS[46784] = Fluid3D([9663,9527,10271,9812],0); -ELEMENTS[46785] = Fluid3D([10271,9663,9812,9970],0); -ELEMENTS[46786] = Fluid3D([9663,9812,9970,8710],0); -ELEMENTS[46787] = Fluid3D([9663,9527,9812,8710],0); -ELEMENTS[46788] = Fluid3D([8988,8710,9663,9970],0); -ELEMENTS[46789] = Fluid3D([10271,9663,9970,8988],0); -ELEMENTS[46790] = Fluid3D([8710,9171,9527,8426],0); -ELEMENTS[46791] = Fluid3D([8988,8261,8710,8133],0); -ELEMENTS[46792] = Fluid3D([8261,8710,8133,7470],0); -ELEMENTS[46793] = Fluid3D([8710,8988,8133,8860],0); -ELEMENTS[46794] = Fluid3D([13297,13767,14271,14382],0); -ELEMENTS[46795] = Fluid3D([12205,12851,11890,12236],0); -ELEMENTS[46796] = Fluid3D([1966,1808,1807,1849],0); -ELEMENTS[46797] = Fluid3D([17034,16606,16711,16543],0); -ELEMENTS[46798] = Fluid3D([6921,6766,7639,6993],0); -ELEMENTS[46799] = Fluid3D([9467,9153,8273,8362],0); -ELEMENTS[46800] = Fluid3D([14601,14914,15153,14982],0); -ELEMENTS[46801] = Fluid3D([4626,4100,4632,4172],0); -ELEMENTS[46802] = Fluid3D([18470,18452,18502,18378],0); -ELEMENTS[46803] = Fluid3D([6982,6140,6832,7244],0); -ELEMENTS[46804] = Fluid3D([11905,11749,11869,11417],0); -ELEMENTS[46805] = Fluid3D([15535,15022,15633,15414],0); -ELEMENTS[46806] = Fluid3D([9698,10388,8969,9955],0); -ELEMENTS[46807] = Fluid3D([15670,16409,16175,16106],0); -ELEMENTS[46808] = Fluid3D([18131,18233,18191,18289],0); -ELEMENTS[46809] = Fluid3D([18191,18131,18289,17932],0); -ELEMENTS[46810] = Fluid3D([18131,18233,18289,18306],0); -ELEMENTS[46811] = Fluid3D([18131,18233,18306,18121],0); -ELEMENTS[46812] = Fluid3D([18289,18131,18306,18117],0); -ELEMENTS[46813] = Fluid3D([10905,11207,10782,11098],0); -ELEMENTS[46814] = Fluid3D([17748,17794,17752,18097],0); -ELEMENTS[46815] = Fluid3D([12380,12969,11901,13023],0); -ELEMENTS[46816] = Fluid3D([15370,15579,15789,15943],0); -ELEMENTS[46817] = Fluid3D([15789,15370,15943,15487],0); -ELEMENTS[46818] = Fluid3D([15943,15789,15487,16313],0); -ELEMENTS[46819] = Fluid3D([15943,15789,16313,16363],0); -ELEMENTS[46820] = Fluid3D([2648,3080,3053,3098],0); -ELEMENTS[46821] = Fluid3D([3080,3053,3098,3444],0); -ELEMENTS[46822] = Fluid3D([7775,7153,7090,6776],0); -ELEMENTS[46823] = Fluid3D([10194,9549,10219,11073],0); -ELEMENTS[46824] = Fluid3D([6476,6998,6112,6950],0); -ELEMENTS[46825] = Fluid3D([6476,6998,6950,7266],0); -ELEMENTS[46826] = Fluid3D([8265,8885,7678,7821],0); -ELEMENTS[46827] = Fluid3D([7678,8265,7821,7871],0); -ELEMENTS[46828] = Fluid3D([8265,8885,7821,8389],0); -ELEMENTS[46829] = Fluid3D([8493,9295,9148,9257],0); -ELEMENTS[46830] = Fluid3D([7628,7210,6789,6892],0); -ELEMENTS[46831] = Fluid3D([5567,5703,6204,5442],0); -ELEMENTS[46832] = Fluid3D([3700,3974,4116,3586],0); -ELEMENTS[46833] = Fluid3D([10965,11239,10605,11921],0); -ELEMENTS[46834] = Fluid3D([5526,6104,5633,6149],0); -ELEMENTS[46835] = Fluid3D([12320,12182,13022,12805],0); -ELEMENTS[46836] = Fluid3D([9631,9317,10402,9484],0); -ELEMENTS[46837] = Fluid3D([10546,11501,10767,11014],0); -ELEMENTS[46838] = Fluid3D([2553,2535,2327,2378],0); -ELEMENTS[46839] = Fluid3D([2535,2327,2378,2137],0); -ELEMENTS[46840] = Fluid3D([2553,2535,2378,2872],0); -ELEMENTS[46841] = Fluid3D([4315,4653,4788,4365],0); -ELEMENTS[46842] = Fluid3D([9062,9613,9582,10207],0); -ELEMENTS[46843] = Fluid3D([17998,17727,17923,18012],0); -ELEMENTS[46844] = Fluid3D([4195,4128,4655,4700],0); -ELEMENTS[46845] = Fluid3D([17909,17958,17936,18264],0); -ELEMENTS[46846] = Fluid3D([5488,4976,5059,4839],0); -ELEMENTS[46847] = Fluid3D([14483,13301,14173,13377],0); -ELEMENTS[46848] = Fluid3D([13301,14173,13377,13443],0); -ELEMENTS[46849] = Fluid3D([13377,13301,13443,12668],0); -ELEMENTS[46850] = Fluid3D([13443,13377,12668,13124],0); -ELEMENTS[46851] = Fluid3D([13301,14173,13443,13984],0); -ELEMENTS[46852] = Fluid3D([4340,4765,4182,4414],0); -ELEMENTS[46853] = Fluid3D([9852,9083,8643,9464],0); -ELEMENTS[46854] = Fluid3D([8309,7976,8573,8849],0); -ELEMENTS[46855] = Fluid3D([7976,8573,8849,8065],0); -ELEMENTS[46856] = Fluid3D([8849,7976,8065,8309],0); -ELEMENTS[46857] = Fluid3D([7976,8065,8309,7613],0); -ELEMENTS[46858] = Fluid3D([7976,8065,7613,6806],0); -ELEMENTS[46859] = Fluid3D([2185,2353,2485,2275],0); -ELEMENTS[46860] = Fluid3D([2185,2353,2275,2311],0); -ELEMENTS[46861] = Fluid3D([5909,6020,5685,6314],0); -ELEMENTS[46862] = Fluid3D([9142,8188,8221,8750],0); -ELEMENTS[46863] = Fluid3D([4989,5125,4560,4741],0); -ELEMENTS[46864] = Fluid3D([9984,10096,9153,9231],0); -ELEMENTS[46865] = Fluid3D([12326,11609,11604,12348],0); -ELEMENTS[46866] = Fluid3D([6653,6690,6645,7471],0); -ELEMENTS[46867] = Fluid3D([5985,6086,5508,5555],0); -ELEMENTS[46868] = Fluid3D([11645,10586,11543,11300],0); -ELEMENTS[46869] = Fluid3D([13332,13139,13193,12373],0); -ELEMENTS[46870] = Fluid3D([16998,16801,16560,17116],0); -ELEMENTS[46871] = Fluid3D([8648,9255,9597,8379],0); -ELEMENTS[46872] = Fluid3D([5715,6374,5973,6363],0); -ELEMENTS[46873] = Fluid3D([11525,11906,11702,12619],0); -ELEMENTS[46874] = Fluid3D([11034,10005,10575,10764],0); -ELEMENTS[46875] = Fluid3D([6516,7010,6527,7517],0); -ELEMENTS[46876] = Fluid3D([6516,7010,7517,7329],0); -ELEMENTS[46877] = Fluid3D([6527,6516,7517,6901],0); -ELEMENTS[46878] = Fluid3D([7553,6841,7252,7978],0); -ELEMENTS[46879] = Fluid3D([11656,11631,10604,10788],0); -ELEMENTS[46880] = Fluid3D([11631,10604,10788,11726],0); -ELEMENTS[46881] = Fluid3D([10788,11631,11726,12082],0); -ELEMENTS[46882] = Fluid3D([13203,13874,13871,14161],0); -ELEMENTS[46883] = Fluid3D([6468,6051,6432,6741],0); -ELEMENTS[46884] = Fluid3D([4814,4798,4834,5329],0); -ELEMENTS[46885] = Fluid3D([8834,9146,8387,9284],0); -ELEMENTS[46886] = Fluid3D([9146,8387,9284,9112],0); -ELEMENTS[46887] = Fluid3D([9284,9146,9112,10040],0); -ELEMENTS[46888] = Fluid3D([9146,8387,9112,8778],0); -ELEMENTS[46889] = Fluid3D([9112,9146,8778,10040],0); -ELEMENTS[46890] = Fluid3D([8834,9146,9284,9687],0); -ELEMENTS[46891] = Fluid3D([8387,9284,9112,8922],0); -ELEMENTS[46892] = Fluid3D([8387,9112,8778,7935],0); -ELEMENTS[46893] = Fluid3D([17818,17546,17501,17450],0); -ELEMENTS[46894] = Fluid3D([13593,13948,13146,13163],0); -ELEMENTS[46895] = Fluid3D([13593,13948,13163,13623],0); -ELEMENTS[46896] = Fluid3D([13163,13593,13623,13322],0); -ELEMENTS[46897] = Fluid3D([13948,13163,13623,13304],0); -ELEMENTS[46898] = Fluid3D([13623,13163,13322,12643],0); -ELEMENTS[46899] = Fluid3D([13593,13948,13623,14559],0); -ELEMENTS[46900] = Fluid3D([13146,13593,13163,12643],0); -ELEMENTS[46901] = Fluid3D([13163,13593,13322,12643],0); -ELEMENTS[46902] = Fluid3D([13948,13163,13304,13146],0); -ELEMENTS[46903] = Fluid3D([5824,5258,5566,5298],0); -ELEMENTS[46904] = Fluid3D([5316,4714,4815,5008],0); -ELEMENTS[46905] = Fluid3D([6557,6489,7000,7403],0); -ELEMENTS[46906] = Fluid3D([3080,3126,3416,3102],0); -ELEMENTS[46907] = Fluid3D([3416,3080,3102,3065],0); -ELEMENTS[46908] = Fluid3D([3126,3416,3102,3504],0); -ELEMENTS[46909] = Fluid3D([3126,3416,3504,3308],0); -ELEMENTS[46910] = Fluid3D([3416,3102,3504,3516],0); -ELEMENTS[46911] = Fluid3D([3504,3416,3516,3770],0); -ELEMENTS[46912] = Fluid3D([3504,3416,3770,3308],0); -ELEMENTS[46913] = Fluid3D([3416,3516,3770,3669],0); -ELEMENTS[46914] = Fluid3D([3770,3416,3669,3308],0); -ELEMENTS[46915] = Fluid3D([3416,3102,3516,3065],0); -ELEMENTS[46916] = Fluid3D([3416,3516,3669,3065],0); -ELEMENTS[46917] = Fluid3D([3516,3770,3669,3906],0); -ELEMENTS[46918] = Fluid3D([3770,3669,3906,4372],0); -ELEMENTS[46919] = Fluid3D([7609,6969,6750,6458],0); -ELEMENTS[46920] = Fluid3D([6750,7609,6458,7218],0); -ELEMENTS[46921] = Fluid3D([2134,2373,2214,2041],0); -ELEMENTS[46922] = Fluid3D([18104,17808,18120,17983],0); -ELEMENTS[46923] = Fluid3D([18120,18104,17983,18242],0); -ELEMENTS[46924] = Fluid3D([4690,4880,4860,5443],0); -ELEMENTS[46925] = Fluid3D([2240,2116,2064,2340],0); -ELEMENTS[46926] = Fluid3D([2064,2240,2340,2114],0); -ELEMENTS[46927] = Fluid3D([2064,2240,2114,2062],0); -ELEMENTS[46928] = Fluid3D([15339,15366,15664,16213],0); -ELEMENTS[46929] = Fluid3D([14332,14851,14868,14997],0); -ELEMENTS[46930] = Fluid3D([14851,14868,14997,15596],0); -ELEMENTS[46931] = Fluid3D([12322,11532,12611,11717],0); -ELEMENTS[46932] = Fluid3D([12611,12322,11717,12527],0); -ELEMENTS[46933] = Fluid3D([7973,7393,7223,8103],0); -ELEMENTS[46934] = Fluid3D([3141,3485,3222,2963],0); -ELEMENTS[46935] = Fluid3D([11955,12553,13004,12398],0); -ELEMENTS[46936] = Fluid3D([13004,11955,12398,12156],0); -ELEMENTS[46937] = Fluid3D([11955,12553,12398,12217],0); -ELEMENTS[46938] = Fluid3D([12398,11955,12217,11559],0); -ELEMENTS[46939] = Fluid3D([12398,11955,11559,11732],0); -ELEMENTS[46940] = Fluid3D([12398,11955,11732,12156],0); -ELEMENTS[46941] = Fluid3D([12609,12205,11519,11708],0); -ELEMENTS[46942] = Fluid3D([9338,9219,8633,8331],0); -ELEMENTS[46943] = Fluid3D([5713,5377,5463,5130],0); -ELEMENTS[46944] = Fluid3D([5463,5713,5130,5143],0); -ELEMENTS[46945] = Fluid3D([14143,13719,13661,14651],0); -ELEMENTS[46946] = Fluid3D([14143,13719,14651,14557],0); -ELEMENTS[46947] = Fluid3D([13661,14143,14651,14305],0); -ELEMENTS[46948] = Fluid3D([13670,13699,14262,14476],0); -ELEMENTS[46949] = Fluid3D([16753,16871,17068,17099],0); -ELEMENTS[46950] = Fluid3D([17068,16753,17099,17097],0); -ELEMENTS[46951] = Fluid3D([16753,17099,17097,16580],0); -ELEMENTS[46952] = Fluid3D([17099,17068,17097,17501],0); -ELEMENTS[46953] = Fluid3D([17097,17099,17501,17528],0); -ELEMENTS[46954] = Fluid3D([16753,16871,17099,16456],0); -ELEMENTS[46955] = Fluid3D([17097,17099,17528,17228],0); -ELEMENTS[46956] = Fluid3D([17068,16753,17097,16580],0); -ELEMENTS[46957] = Fluid3D([9210,9753,8330,8830],0); -ELEMENTS[46958] = Fluid3D([9210,9753,8830,9265],0); -ELEMENTS[46959] = Fluid3D([4353,4842,4754,4873],0); -ELEMENTS[46960] = Fluid3D([5656,5874,5220,5432],0); -ELEMENTS[46961] = Fluid3D([7647,7917,8343,8615],0); -ELEMENTS[46962] = Fluid3D([13883,13736,13739,12906],0); -ELEMENTS[46963] = Fluid3D([16783,16340,16977,16834],0); -ELEMENTS[46964] = Fluid3D([16977,16783,16834,17248],0); -ELEMENTS[46965] = Fluid3D([16977,16783,17248,17258],0); -ELEMENTS[46966] = Fluid3D([11693,11526,10739,10970],0); -ELEMENTS[46967] = Fluid3D([13054,12827,13469,12513],0); -ELEMENTS[46968] = Fluid3D([13054,12827,12513,12436],0); -ELEMENTS[46969] = Fluid3D([13054,12827,12436,13105],0); -ELEMENTS[46970] = Fluid3D([12436,13054,13105,12632],0); -ELEMENTS[46971] = Fluid3D([12436,13054,12632,12574],0); -ELEMENTS[46972] = Fluid3D([13105,12436,12632,12024],0); -ELEMENTS[46973] = Fluid3D([12513,13054,12436,12321],0); -ELEMENTS[46974] = Fluid3D([12513,13054,12321,12991],0); -ELEMENTS[46975] = Fluid3D([12321,12513,12991,12370],0); -ELEMENTS[46976] = Fluid3D([12321,12513,12370,11984],0); -ELEMENTS[46977] = Fluid3D([12513,12370,11984,12874],0); -ELEMENTS[46978] = Fluid3D([12370,11984,12874,12336],0); -ELEMENTS[46979] = Fluid3D([12991,12321,12370,11925],0); -ELEMENTS[46980] = Fluid3D([12321,12513,11984,11742],0); -ELEMENTS[46981] = Fluid3D([12321,12513,11742,12436],0); -ELEMENTS[46982] = Fluid3D([12321,12370,11925,11984],0); -ELEMENTS[46983] = Fluid3D([12513,11984,11742,12827],0); -ELEMENTS[46984] = Fluid3D([12370,11925,11984,12336],0); -ELEMENTS[46985] = Fluid3D([11984,12513,12874,12827],0); -ELEMENTS[46986] = Fluid3D([12513,12370,12874,12991],0); -ELEMENTS[46987] = Fluid3D([12370,12991,11925,13209],0); -ELEMENTS[46988] = Fluid3D([11984,12874,12336,12782],0); -ELEMENTS[46989] = Fluid3D([11742,12513,12827,12436],0); -ELEMENTS[46990] = Fluid3D([13469,13054,12513,12991],0); -ELEMENTS[46991] = Fluid3D([12827,13469,12513,12874],0); -ELEMENTS[46992] = Fluid3D([13469,12513,12874,12991],0); -ELEMENTS[46993] = Fluid3D([16032,16340,15909,15864],0); -ELEMENTS[46994] = Fluid3D([12224,12635,11769,12932],0); -ELEMENTS[46995] = Fluid3D([7921,7842,7208,6669],0); -ELEMENTS[46996] = Fluid3D([7842,7208,6669,6953],0); -ELEMENTS[46997] = Fluid3D([7208,6669,6953,6553],0); -ELEMENTS[46998] = Fluid3D([7208,6669,6553,7112],0); -ELEMENTS[46999] = Fluid3D([6953,7208,6553,7112],0); -ELEMENTS[47000] = Fluid3D([14513,14277,14751,13809],0); -ELEMENTS[47001] = Fluid3D([14277,14751,13809,14941],0); -ELEMENTS[47002] = Fluid3D([14513,14277,13809,13754],0); -ELEMENTS[47003] = Fluid3D([6394,6286,6611,5828],0); -ELEMENTS[47004] = Fluid3D([11057,12015,11570,11823],0); -ELEMENTS[47005] = Fluid3D([2572,2385,2384,2680],0); -ELEMENTS[47006] = Fluid3D([12642,11927,12669,11896],0); -ELEMENTS[47007] = Fluid3D([4072,4116,3681,4296],0); -ELEMENTS[47008] = Fluid3D([17187,17120,16739,16950],0); -ELEMENTS[47009] = Fluid3D([17507,17162,17049,16958],0); -ELEMENTS[47010] = Fluid3D([2630,2816,2374,2529],0); -ELEMENTS[47011] = Fluid3D([2630,2816,2529,2806],0); -ELEMENTS[47012] = Fluid3D([2630,2816,2806,2941],0); -ELEMENTS[47013] = Fluid3D([7894,8148,7274,7153],0); -ELEMENTS[47014] = Fluid3D([12142,11480,11843,10835],0); -ELEMENTS[47015] = Fluid3D([15835,15228,15293,15692],0); -ELEMENTS[47016] = Fluid3D([12046,11148,11481,10806],0); -ELEMENTS[47017] = Fluid3D([5967,6626,6395,6315],0); -ELEMENTS[47018] = Fluid3D([6058,5720,6208,6518],0); -ELEMENTS[47019] = Fluid3D([17895,18157,18149,17863],0); -ELEMENTS[47020] = Fluid3D([16701,16856,16837,17161],0); -ELEMENTS[47021] = Fluid3D([16701,16856,17161,17042],0); -ELEMENTS[47022] = Fluid3D([16856,16837,17161,17270],0); -ELEMENTS[47023] = Fluid3D([16856,17161,17042,17213],0); -ELEMENTS[47024] = Fluid3D([16856,17161,17213,17008],0); -ELEMENTS[47025] = Fluid3D([17213,16856,17008,17026],0); -ELEMENTS[47026] = Fluid3D([17213,16856,17026,17042],0); -ELEMENTS[47027] = Fluid3D([17008,17213,17026,17462],0); -ELEMENTS[47028] = Fluid3D([16856,17161,17008,17270],0); -ELEMENTS[47029] = Fluid3D([9709,10215,9320,9788],0); -ELEMENTS[47030] = Fluid3D([12210,12789,12946,12872],0); -ELEMENTS[47031] = Fluid3D([15988,15669,15897,16337],0); -ELEMENTS[47032] = Fluid3D([18094,17966,18212,17852],0); -ELEMENTS[47033] = Fluid3D([4140,4032,4520,4159],0); -ELEMENTS[47034] = Fluid3D([4520,4140,4159,4240],0); -ELEMENTS[47035] = Fluid3D([3009,2860,2927,2804],0); -ELEMENTS[47036] = Fluid3D([2927,3009,2804,3313],0); -ELEMENTS[47037] = Fluid3D([2860,2927,2804,2538],0); -ELEMENTS[47038] = Fluid3D([3009,2860,2804,2636],0); -ELEMENTS[47039] = Fluid3D([5645,5131,5378,4837],0); -ELEMENTS[47040] = Fluid3D([15160,14770,14389,14216],0); -ELEMENTS[47041] = Fluid3D([14548,14728,14219,14158],0); -ELEMENTS[47042] = Fluid3D([14548,14728,14158,14656],0); -ELEMENTS[47043] = Fluid3D([14728,14158,14656,14594],0); -ELEMENTS[47044] = Fluid3D([7079,6317,6724,6964],0); -ELEMENTS[47045] = Fluid3D([6317,6724,6964,6153],0); -ELEMENTS[47046] = Fluid3D([2724,2976,2652,2964],0); -ELEMENTS[47047] = Fluid3D([2724,2976,2964,3064],0); -ELEMENTS[47048] = Fluid3D([2652,2724,2964,2805],0); -ELEMENTS[47049] = Fluid3D([2724,2964,2805,2817],0); -ELEMENTS[47050] = Fluid3D([2724,2964,2817,3064],0); -ELEMENTS[47051] = Fluid3D([10629,11321,11950,11187],0); -ELEMENTS[47052] = Fluid3D([3285,3050,3528,3157],0); -ELEMENTS[47053] = Fluid3D([8141,8726,9233,8390],0); -ELEMENTS[47054] = Fluid3D([8726,9233,8390,9122],0); -ELEMENTS[47055] = Fluid3D([8726,9233,9122,9457],0); -ELEMENTS[47056] = Fluid3D([8390,8726,9122,8144],0); -ELEMENTS[47057] = Fluid3D([7409,7626,7363,6867],0); -ELEMENTS[47058] = Fluid3D([5654,5605,6168,5772],0); -ELEMENTS[47059] = Fluid3D([14010,13870,14322,14462],0); -ELEMENTS[47060] = Fluid3D([14010,13870,14462,13762],0); -ELEMENTS[47061] = Fluid3D([14910,14848,15147,15558],0); -ELEMENTS[47062] = Fluid3D([12896,13055,13711,14064],0); -ELEMENTS[47063] = Fluid3D([9316,9911,10109,10372],0); -ELEMENTS[47064] = Fluid3D([9403,10153,9093,9011],0); -ELEMENTS[47065] = Fluid3D([3844,3822,4356,3984],0); -ELEMENTS[47066] = Fluid3D([8906,9534,8898,9883],0); -ELEMENTS[47067] = Fluid3D([9534,8898,9883,9202],0); -ELEMENTS[47068] = Fluid3D([9883,9534,9202,10297],0); -ELEMENTS[47069] = Fluid3D([9883,9534,10297,10675],0); -ELEMENTS[47070] = Fluid3D([9883,9534,10675,10139],0); -ELEMENTS[47071] = Fluid3D([9883,9534,10139,8906],0); -ELEMENTS[47072] = Fluid3D([5149,4804,5397,5135],0); -ELEMENTS[47073] = Fluid3D([12079,11225,11366,11972],0); -ELEMENTS[47074] = Fluid3D([12673,13157,13308,13633],0); -ELEMENTS[47075] = Fluid3D([8635,8629,9459,9544],0); -ELEMENTS[47076] = Fluid3D([12208,12636,12842,13497],0); -ELEMENTS[47077] = Fluid3D([10629,10218,11187,10256],0); -ELEMENTS[47078] = Fluid3D([10629,10218,10256,9456],0); -ELEMENTS[47079] = Fluid3D([4990,4730,4538,5219],0); -ELEMENTS[47080] = Fluid3D([4538,4990,5219,5096],0); -ELEMENTS[47081] = Fluid3D([4990,5219,5096,5737],0); -ELEMENTS[47082] = Fluid3D([4990,4730,5219,5423],0); -ELEMENTS[47083] = Fluid3D([5219,4990,5423,5737],0); -ELEMENTS[47084] = Fluid3D([17692,17456,17435,17373],0); -ELEMENTS[47085] = Fluid3D([12803,13586,13504,13705],0); -ELEMENTS[47086] = Fluid3D([6215,6679,6900,6468],0); -ELEMENTS[47087] = Fluid3D([14196,14387,14719,14895],0); -ELEMENTS[47088] = Fluid3D([14719,14196,14895,14405],0); -ELEMENTS[47089] = Fluid3D([14719,14196,14405,13520],0); -ELEMENTS[47090] = Fluid3D([14196,14895,14405,14609],0); -ELEMENTS[47091] = Fluid3D([16701,16397,16134,16161],0); -ELEMENTS[47092] = Fluid3D([11883,11568,12291,12516],0); -ELEMENTS[47093] = Fluid3D([11568,12291,12516,12219],0); -ELEMENTS[47094] = Fluid3D([12291,11883,12516,12904],0); -ELEMENTS[47095] = Fluid3D([12516,12291,12904,13233],0); -ELEMENTS[47096] = Fluid3D([12516,12291,13233,12219],0); -ELEMENTS[47097] = Fluid3D([12904,12516,13233,13426],0); -ELEMENTS[47098] = Fluid3D([12291,12904,13233,12975],0); -ELEMENTS[47099] = Fluid3D([13233,12291,12975,12542],0); -ELEMENTS[47100] = Fluid3D([12291,12975,12542,11508],0); -ELEMENTS[47101] = Fluid3D([12291,12904,12975,11968],0); -ELEMENTS[47102] = Fluid3D([12904,13233,12975,13831],0); -ELEMENTS[47103] = Fluid3D([12904,13233,13831,13426],0); -ELEMENTS[47104] = Fluid3D([13233,13831,13426,13133],0); -ELEMENTS[47105] = Fluid3D([13233,12291,12542,12219],0); -ELEMENTS[47106] = Fluid3D([13233,12975,13831,14054],0); -ELEMENTS[47107] = Fluid3D([12975,13233,12542,13559],0); -ELEMENTS[47108] = Fluid3D([12975,13233,13559,14054],0); -ELEMENTS[47109] = Fluid3D([13233,13559,14054,13831],0); -ELEMENTS[47110] = Fluid3D([13233,13559,13831,13133],0); -ELEMENTS[47111] = Fluid3D([13233,13559,13133,12695],0); -ELEMENTS[47112] = Fluid3D([11883,12516,12904,12838],0); -ELEMENTS[47113] = Fluid3D([12516,12904,12838,13426],0); -ELEMENTS[47114] = Fluid3D([12904,11883,12838,12747],0); -ELEMENTS[47115] = Fluid3D([12838,12904,12747,13567],0); -ELEMENTS[47116] = Fluid3D([12838,12904,13567,13426],0); -ELEMENTS[47117] = Fluid3D([12904,12747,13567,13386],0); -ELEMENTS[47118] = Fluid3D([12904,12747,13386,12975],0); -ELEMENTS[47119] = Fluid3D([13386,12904,12975,13831],0); -ELEMENTS[47120] = Fluid3D([13567,12904,13386,13831],0); -ELEMENTS[47121] = Fluid3D([12747,13386,12975,12845],0); -ELEMENTS[47122] = Fluid3D([12904,12747,12975,11968],0); -ELEMENTS[47123] = Fluid3D([12747,13567,13386,13659],0); -ELEMENTS[47124] = Fluid3D([13386,12747,13659,13859],0); -ELEMENTS[47125] = Fluid3D([13659,13386,13859,14317],0); -ELEMENTS[47126] = Fluid3D([13567,13386,13659,14317],0); -ELEMENTS[47127] = Fluid3D([12747,13567,13659,13241],0); -ELEMENTS[47128] = Fluid3D([13659,12747,13241,13614],0); -ELEMENTS[47129] = Fluid3D([13241,13659,13614,14104],0); -ELEMENTS[47130] = Fluid3D([13659,13614,14104,14609],0); -ELEMENTS[47131] = Fluid3D([13614,13241,14104,14196],0); -ELEMENTS[47132] = Fluid3D([13241,13659,14104,13567],0); -ELEMENTS[47133] = Fluid3D([14104,13659,14609,14113],0); -ELEMENTS[47134] = Fluid3D([14609,14104,14113,14405],0); -ELEMENTS[47135] = Fluid3D([14609,14104,14405,14196],0); -ELEMENTS[47136] = Fluid3D([14104,14405,14196,13640],0); -ELEMENTS[47137] = Fluid3D([14104,14405,13640,14113],0); -ELEMENTS[47138] = Fluid3D([14405,14196,13640,13520],0); -ELEMENTS[47139] = Fluid3D([14196,14104,13640,13241],0); -ELEMENTS[47140] = Fluid3D([14104,13640,13241,13567],0); -ELEMENTS[47141] = Fluid3D([14104,13614,14196,14369],0); -ELEMENTS[47142] = Fluid3D([13659,14104,13567,14113],0); -ELEMENTS[47143] = Fluid3D([14104,13567,14113,13640],0); -ELEMENTS[47144] = Fluid3D([13567,13659,14113,14317],0); -ELEMENTS[47145] = Fluid3D([14113,13567,14317,13831],0); -ELEMENTS[47146] = Fluid3D([14113,13567,13831,13426],0); -ELEMENTS[47147] = Fluid3D([13640,13241,13567,13162],0); -ELEMENTS[47148] = Fluid3D([13640,13241,13162,12590],0); -ELEMENTS[47149] = Fluid3D([13162,13640,12590,13520],0); -ELEMENTS[47150] = Fluid3D([13162,13640,13520,14038],0); -ELEMENTS[47151] = Fluid3D([13162,13640,14038,13728],0); -ELEMENTS[47152] = Fluid3D([13640,13520,14038,14405],0); -ELEMENTS[47153] = Fluid3D([14038,13640,14405,13728],0); -ELEMENTS[47154] = Fluid3D([13614,14104,14609,14369],0); -ELEMENTS[47155] = Fluid3D([13640,14196,13241,13574],0); -ELEMENTS[47156] = Fluid3D([12747,13567,13241,12838],0); -ELEMENTS[47157] = Fluid3D([13567,12904,13831,13426],0); -ELEMENTS[47158] = Fluid3D([14446,15121,14568,14975],0); -ELEMENTS[47159] = Fluid3D([8929,9473,9069,9646],0); -ELEMENTS[47160] = Fluid3D([8929,9473,9646,10254],0); -ELEMENTS[47161] = Fluid3D([9473,9646,10254,10421],0); -ELEMENTS[47162] = Fluid3D([9646,10254,10421,9973],0); -ELEMENTS[47163] = Fluid3D([9646,10254,9973,10542],0); -ELEMENTS[47164] = Fluid3D([9646,10254,10542,9582],0); -ELEMENTS[47165] = Fluid3D([9646,10254,9582,8929],0); -ELEMENTS[47166] = Fluid3D([9582,9646,8929,8469],0); -ELEMENTS[47167] = Fluid3D([10254,10542,9582,10207],0); -ELEMENTS[47168] = Fluid3D([10542,9646,9582,9559],0); -ELEMENTS[47169] = Fluid3D([9646,9582,9559,8469],0); -ELEMENTS[47170] = Fluid3D([9473,9646,10421,9069],0); -ELEMENTS[47171] = Fluid3D([15134,14855,14290,14293],0); -ELEMENTS[47172] = Fluid3D([9865,10524,10681,9906],0); -ELEMENTS[47173] = Fluid3D([2409,2427,2606,2701],0); -ELEMENTS[47174] = Fluid3D([2606,2409,2701,2550],0); -ELEMENTS[47175] = Fluid3D([15332,14702,15322,15431],0); -ELEMENTS[47176] = Fluid3D([15322,15332,15431,16048],0); -ELEMENTS[47177] = Fluid3D([13543,14270,14183,14081],0); -ELEMENTS[47178] = Fluid3D([2928,2601,2687,2872],0); -ELEMENTS[47179] = Fluid3D([14170,14132,13451,13144],0); -ELEMENTS[47180] = Fluid3D([2683,2997,2718,3077],0); -ELEMENTS[47181] = Fluid3D([5288,5569,5832,5222],0); -ELEMENTS[47182] = Fluid3D([15979,15731,15467,16014],0); -ELEMENTS[47183] = Fluid3D([2870,2943,2740,2512],0); -ELEMENTS[47184] = Fluid3D([15577,15223,15219,15850],0); -ELEMENTS[47185] = Fluid3D([15577,15223,15850,15892],0); -ELEMENTS[47186] = Fluid3D([16921,16518,16583,16761],0); -ELEMENTS[47187] = Fluid3D([17504,17067,17292,17421],0); -ELEMENTS[47188] = Fluid3D([17292,17504,17421,17707],0); -ELEMENTS[47189] = Fluid3D([17504,17421,17707,17822],0); -ELEMENTS[47190] = Fluid3D([17292,17504,17707,17691],0); -ELEMENTS[47191] = Fluid3D([15646,15392,16048,15785],0); -ELEMENTS[47192] = Fluid3D([2577,2279,2387,2437],0); -ELEMENTS[47193] = Fluid3D([2387,2577,2437,2609],0); -ELEMENTS[47194] = Fluid3D([2577,2437,2609,2468],0); -ELEMENTS[47195] = Fluid3D([2437,2609,2468,2578],0); -ELEMENTS[47196] = Fluid3D([2437,2609,2578,2344],0); -ELEMENTS[47197] = Fluid3D([2437,2609,2344,2387],0); -ELEMENTS[47198] = Fluid3D([2344,2437,2387,2279],0); -ELEMENTS[47199] = Fluid3D([2577,2437,2468,2279],0); -ELEMENTS[47200] = Fluid3D([2437,2468,2279,2132],0); -ELEMENTS[47201] = Fluid3D([3661,3414,3327,3180],0); -ELEMENTS[47202] = Fluid3D([13974,13246,13671,12996],0); -ELEMENTS[47203] = Fluid3D([15320,14539,14769,14397],0); -ELEMENTS[47204] = Fluid3D([10087,9487,10305,9504],0); -ELEMENTS[47205] = Fluid3D([10087,9487,9504,9476],0); -ELEMENTS[47206] = Fluid3D([7224,7377,7222,6245],0); -ELEMENTS[47207] = Fluid3D([15867,16120,16502,16265],0); -ELEMENTS[47208] = Fluid3D([5339,5087,5898,5809],0); -ELEMENTS[47209] = Fluid3D([9148,9628,8674,8875],0); -ELEMENTS[47210] = Fluid3D([10154,9875,10712,10953],0); -ELEMENTS[47211] = Fluid3D([10154,9875,10953,10123],0); -ELEMENTS[47212] = Fluid3D([10154,9875,10123,9082],0); -ELEMENTS[47213] = Fluid3D([6946,6864,6747,7634],0); -ELEMENTS[47214] = Fluid3D([5340,5545,5855,5910],0); -ELEMENTS[47215] = Fluid3D([8399,8459,8910,9400],0); -ELEMENTS[47216] = Fluid3D([16241,16508,16612,16770],0); -ELEMENTS[47217] = Fluid3D([16241,16508,16770,16899],0); -ELEMENTS[47218] = Fluid3D([16508,16770,16899,16902],0); -ELEMENTS[47219] = Fluid3D([16508,16770,16902,16612],0); -ELEMENTS[47220] = Fluid3D([16770,16902,16612,16350],0); -ELEMENTS[47221] = Fluid3D([16770,16899,16902,17152],0); -ELEMENTS[47222] = Fluid3D([16902,16770,17152,17176],0); -ELEMENTS[47223] = Fluid3D([16902,16508,16612,17190],0); -ELEMENTS[47224] = Fluid3D([16770,16899,17152,16867],0); -ELEMENTS[47225] = Fluid3D([17152,16770,16867,17124],0); -ELEMENTS[47226] = Fluid3D([17152,16902,17176,17190],0); -ELEMENTS[47227] = Fluid3D([17152,16902,17190,16899],0); -ELEMENTS[47228] = Fluid3D([16770,16899,16867,16517],0); -ELEMENTS[47229] = Fluid3D([16867,16770,16517,17124],0); -ELEMENTS[47230] = Fluid3D([16902,16770,17176,16796],0); -ELEMENTS[47231] = Fluid3D([16899,16508,16902,17190],0); -ELEMENTS[47232] = Fluid3D([17176,16902,16796,16876],0); -ELEMENTS[47233] = Fluid3D([17176,16902,16876,17190],0); -ELEMENTS[47234] = Fluid3D([16796,17176,16876,16882],0); -ELEMENTS[47235] = Fluid3D([16899,16867,16517,16577],0); -ELEMENTS[47236] = Fluid3D([16867,16517,16577,16540],0); -ELEMENTS[47237] = Fluid3D([16867,16517,16540,16844],0); -ELEMENTS[47238] = Fluid3D([16867,16517,16844,17124],0); -ELEMENTS[47239] = Fluid3D([16517,16577,16540,15888],0); -ELEMENTS[47240] = Fluid3D([16612,16902,17190,16876],0); -ELEMENTS[47241] = Fluid3D([16612,16902,16876,16350],0); -ELEMENTS[47242] = Fluid3D([11982,12116,11020,11551],0); -ELEMENTS[47243] = Fluid3D([4208,4325,3980,4487],0); -ELEMENTS[47244] = Fluid3D([3980,4208,4487,4309],0); -ELEMENTS[47245] = Fluid3D([4208,4325,4487,4825],0); -ELEMENTS[47246] = Fluid3D([4392,4116,4511,4569],0); -ELEMENTS[47247] = Fluid3D([12519,12889,13371,13020],0); -ELEMENTS[47248] = Fluid3D([16505,16187,16727,16541],0); -ELEMENTS[47249] = Fluid3D([13071,13170,14210,13434],0); -ELEMENTS[47250] = Fluid3D([7284,7300,7303,7937],0); -ELEMENTS[47251] = Fluid3D([7303,7284,7937,8505],0); -ELEMENTS[47252] = Fluid3D([7284,7300,7937,7634],0); -ELEMENTS[47253] = Fluid3D([5601,5588,5783,6191],0); -ELEMENTS[47254] = Fluid3D([16327,16414,15977,16280],0); -ELEMENTS[47255] = Fluid3D([14532,14566,14984,14382],0); -ELEMENTS[47256] = Fluid3D([3175,2890,2981,3145],0); -ELEMENTS[47257] = Fluid3D([2981,3175,3145,3548],0); -ELEMENTS[47258] = Fluid3D([3175,2890,3145,3071],0); -ELEMENTS[47259] = Fluid3D([4803,4147,4645,4618],0); -ELEMENTS[47260] = Fluid3D([4645,4803,4618,5140],0); -ELEMENTS[47261] = Fluid3D([4618,4645,5140,4815],0); -ELEMENTS[47262] = Fluid3D([4803,4618,5140,5120],0); -ELEMENTS[47263] = Fluid3D([4618,5140,5120,4815],0); -ELEMENTS[47264] = Fluid3D([4147,4645,4618,4317],0); -ELEMENTS[47265] = Fluid3D([4645,4618,4317,4815],0); -ELEMENTS[47266] = Fluid3D([4645,4803,5140,5032],0); -ELEMENTS[47267] = Fluid3D([4803,4147,4618,4552],0); -ELEMENTS[47268] = Fluid3D([4618,4147,4317,4591],0); -ELEMENTS[47269] = Fluid3D([4618,4803,4552,4907],0); -ELEMENTS[47270] = Fluid3D([5140,4803,5120,5429],0); -ELEMENTS[47271] = Fluid3D([5120,5140,5429,5516],0); -ELEMENTS[47272] = Fluid3D([5120,5140,5516,4815],0); -ELEMENTS[47273] = Fluid3D([5140,5429,5516,5191],0); -ELEMENTS[47274] = Fluid3D([5516,5140,5191,4815],0); -ELEMENTS[47275] = Fluid3D([5140,4803,5429,5032],0); -ELEMENTS[47276] = Fluid3D([10918,10873,10065,11080],0); -ELEMENTS[47277] = Fluid3D([10556,10119,10093,10867],0); -ELEMENTS[47278] = Fluid3D([18169,18151,18320,18017],0); -ELEMENTS[47279] = Fluid3D([18169,18151,18017,17945],0); -ELEMENTS[47280] = Fluid3D([18151,18320,18017,18291],0); -ELEMENTS[47281] = Fluid3D([2414,2291,2245,2229],0); -ELEMENTS[47282] = Fluid3D([2245,2414,2229,2442],0); -ELEMENTS[47283] = Fluid3D([2245,2414,2442,2469],0); -ELEMENTS[47284] = Fluid3D([4135,4014,4217,3596],0); -ELEMENTS[47285] = Fluid3D([16683,16155,16306,16551],0); -ELEMENTS[47286] = Fluid3D([16306,16683,16551,16926],0); -ELEMENTS[47287] = Fluid3D([5909,5284,5272,5393],0); -ELEMENTS[47288] = Fluid3D([10051,10113,10781,11382],0); -ELEMENTS[47289] = Fluid3D([14520,14122,14880,14685],0); -ELEMENTS[47290] = Fluid3D([14122,14880,14685,14190],0); -ELEMENTS[47291] = Fluid3D([14520,14122,14685,14599],0); -ELEMENTS[47292] = Fluid3D([10324,9819,9833,9205],0); -ELEMENTS[47293] = Fluid3D([9659,10370,10454,10386],0); -ELEMENTS[47294] = Fluid3D([11870,12051,11016,11709],0); -ELEMENTS[47295] = Fluid3D([11543,11716,11594,10775],0); -ELEMENTS[47296] = Fluid3D([11594,11543,10775,11300],0); -ELEMENTS[47297] = Fluid3D([11716,11594,10775,10310],0); -ELEMENTS[47298] = Fluid3D([7612,8187,7339,7955],0); -ELEMENTS[47299] = Fluid3D([12464,11958,11275,11640],0); -ELEMENTS[47300] = Fluid3D([14306,13683,14189,14668],0); -ELEMENTS[47301] = Fluid3D([2465,2234,2420,2261],0); -ELEMENTS[47302] = Fluid3D([15495,15804,15811,16049],0); -ELEMENTS[47303] = Fluid3D([9668,10320,10688,10021],0); -ELEMENTS[47304] = Fluid3D([6777,6872,7428,7561],0); -ELEMENTS[47305] = Fluid3D([13664,14466,13757,13999],0); -ELEMENTS[47306] = Fluid3D([13664,14466,13999,14593],0); -ELEMENTS[47307] = Fluid3D([13999,13664,14593,13741],0); -ELEMENTS[47308] = Fluid3D([13999,13664,13741,13276],0); -ELEMENTS[47309] = Fluid3D([13757,13664,13999,13219],0); -ELEMENTS[47310] = Fluid3D([13664,13999,13219,13276],0); -ELEMENTS[47311] = Fluid3D([13757,13664,13219,12850],0); -ELEMENTS[47312] = Fluid3D([7416,7170,7788,8054],0); -ELEMENTS[47313] = Fluid3D([7170,7788,8054,7407],0); -ELEMENTS[47314] = Fluid3D([13188,13499,13804,13683],0); -ELEMENTS[47315] = Fluid3D([6501,6062,6887,6179],0); -ELEMENTS[47316] = Fluid3D([11171,10791,11562,10157],0); -ELEMENTS[47317] = Fluid3D([17983,18056,18242,18165],0); -ELEMENTS[47318] = Fluid3D([7639,6766,7092,6993],0); -ELEMENTS[47319] = Fluid3D([7092,7639,6993,7886],0); -ELEMENTS[47320] = Fluid3D([7092,7639,7886,8218],0); -ELEMENTS[47321] = Fluid3D([6993,7092,7886,7298],0); -ELEMENTS[47322] = Fluid3D([6993,7092,7298,6643],0); -ELEMENTS[47323] = Fluid3D([7092,7886,7298,6643],0); -ELEMENTS[47324] = Fluid3D([7886,6993,7298,7583],0); -ELEMENTS[47325] = Fluid3D([6993,7092,6643,6766],0); -ELEMENTS[47326] = Fluid3D([7092,6643,6766,6742],0); -ELEMENTS[47327] = Fluid3D([6993,7298,7583,7076],0); -ELEMENTS[47328] = Fluid3D([6993,7298,7076,7220],0); -ELEMENTS[47329] = Fluid3D([7298,7076,7220,8509],0); -ELEMENTS[47330] = Fluid3D([7092,7886,6643,7483],0); -ELEMENTS[47331] = Fluid3D([6643,7092,7483,6742],0); -ELEMENTS[47332] = Fluid3D([7092,7886,7483,8218],0); -ELEMENTS[47333] = Fluid3D([7886,7483,8218,7851],0); -ELEMENTS[47334] = Fluid3D([7483,8218,7851,7391],0); -ELEMENTS[47335] = Fluid3D([7851,7483,7391,6742],0); -ELEMENTS[47336] = Fluid3D([7483,8218,7391,7092],0); -ELEMENTS[47337] = Fluid3D([7391,7483,7092,6742],0); -ELEMENTS[47338] = Fluid3D([4255,4005,4221,4752],0); -ELEMENTS[47339] = Fluid3D([3939,4321,3894,4285],0); -ELEMENTS[47340] = Fluid3D([18491,18334,18393,18483],0); -ELEMENTS[47341] = Fluid3D([8404,9372,8689,8492],0); -ELEMENTS[47342] = Fluid3D([2919,2711,2833,2779],0); -ELEMENTS[47343] = Fluid3D([9468,8650,9185,8851],0); -ELEMENTS[47344] = Fluid3D([11863,10919,10817,11673],0); -ELEMENTS[47345] = Fluid3D([11217,10405,10424,11768],0); -ELEMENTS[47346] = Fluid3D([11217,10405,11768,11861],0); -ELEMENTS[47347] = Fluid3D([14954,14664,15146,15152],0); -ELEMENTS[47348] = Fluid3D([14954,14664,15152,15293],0); -ELEMENTS[47349] = Fluid3D([14664,15152,15293,14310],0); -ELEMENTS[47350] = Fluid3D([15146,14954,15152,15625],0); -ELEMENTS[47351] = Fluid3D([15152,14954,15293,15625],0); -ELEMENTS[47352] = Fluid3D([15293,15152,15625,15738],0); -ELEMENTS[47353] = Fluid3D([15293,15152,15738,15692],0); -ELEMENTS[47354] = Fluid3D([14664,15146,15152,14809],0); -ELEMENTS[47355] = Fluid3D([15152,14664,14809,14310],0); -ELEMENTS[47356] = Fluid3D([15293,15152,15692,15228],0); -ELEMENTS[47357] = Fluid3D([15293,15152,15228,14310],0); -ELEMENTS[47358] = Fluid3D([13038,12372,12448,13403],0); -ELEMENTS[47359] = Fluid3D([7599,8431,7233,8160],0); -ELEMENTS[47360] = Fluid3D([10001,9016,9142,9481],0); -ELEMENTS[47361] = Fluid3D([18444,18414,18431,18596],0); -ELEMENTS[47362] = Fluid3D([4117,3699,4107,3957],0); -ELEMENTS[47363] = Fluid3D([6223,6557,7000,7403],0); -ELEMENTS[47364] = Fluid3D([13827,13097,13613,12921],0); -ELEMENTS[47365] = Fluid3D([12400,11837,11985,11054],0); -ELEMENTS[47366] = Fluid3D([12400,11837,11054,11467],0); -ELEMENTS[47367] = Fluid3D([11837,11054,11467,10562],0); -ELEMENTS[47368] = Fluid3D([11054,12400,11467,11985],0); -ELEMENTS[47369] = Fluid3D([12202,12426,11170,11669],0); -ELEMENTS[47370] = Fluid3D([12202,12426,11669,13126],0); -ELEMENTS[47371] = Fluid3D([11170,12202,11669,11362],0); -ELEMENTS[47372] = Fluid3D([12202,11669,11362,11458],0); -ELEMENTS[47373] = Fluid3D([11189,10615,11171,10855],0); -ELEMENTS[47374] = Fluid3D([11189,10615,10855,10755],0); -ELEMENTS[47375] = Fluid3D([4196,4028,4241,3640],0); -ELEMENTS[47376] = Fluid3D([16980,16870,17341,17282],0); -ELEMENTS[47377] = Fluid3D([7508,7238,7814,8180],0); -ELEMENTS[47378] = Fluid3D([15255,15671,15328,15026],0); -ELEMENTS[47379] = Fluid3D([5606,5235,5848,5531],0); -ELEMENTS[47380] = Fluid3D([12035,12099,12438,13046],0); -ELEMENTS[47381] = Fluid3D([16187,16727,16560,16385],0); -ELEMENTS[47382] = Fluid3D([12273,12732,12333,12950],0); -ELEMENTS[47383] = Fluid3D([14944,15307,14772,15643],0); -ELEMENTS[47384] = Fluid3D([15229,15381,15422,15779],0); -ELEMENTS[47385] = Fluid3D([16055,15746,15589,16248],0); -ELEMENTS[47386] = Fluid3D([15589,16055,16248,16081],0); -ELEMENTS[47387] = Fluid3D([16055,16248,16081,16664],0); -ELEMENTS[47388] = Fluid3D([16055,15746,16248,16607],0); -ELEMENTS[47389] = Fluid3D([15589,16055,16081,15515],0); -ELEMENTS[47390] = Fluid3D([16055,16248,16664,16604],0); -ELEMENTS[47391] = Fluid3D([16055,16248,16604,16607],0); -ELEMENTS[47392] = Fluid3D([16248,16604,16607,16811],0); -ELEMENTS[47393] = Fluid3D([16604,16607,16811,17004],0); -ELEMENTS[47394] = Fluid3D([16811,16604,17004,16664],0); -ELEMENTS[47395] = Fluid3D([16604,16607,17004,16614],0); -ELEMENTS[47396] = Fluid3D([16607,16811,17004,16961],0); -ELEMENTS[47397] = Fluid3D([16248,16604,16811,16664],0); -ELEMENTS[47398] = Fluid3D([16811,17004,16961,17292],0); -ELEMENTS[47399] = Fluid3D([16811,17004,17292,17173],0); -ELEMENTS[47400] = Fluid3D([16811,17004,17173,16664],0); -ELEMENTS[47401] = Fluid3D([17004,17292,17173,17691],0); -ELEMENTS[47402] = Fluid3D([16055,16081,15515,16282],0); -ELEMENTS[47403] = Fluid3D([16055,16081,16282,16664],0); -ELEMENTS[47404] = Fluid3D([16081,15515,16282,15925],0); -ELEMENTS[47405] = Fluid3D([16081,16282,16664,16522],0); -ELEMENTS[47406] = Fluid3D([15515,16055,16282,16099],0); -ELEMENTS[47407] = Fluid3D([16081,16282,16522,15925],0); -ELEMENTS[47408] = Fluid3D([16282,16055,16664,16604],0); -ELEMENTS[47409] = Fluid3D([16282,16055,16604,16614],0); -ELEMENTS[47410] = Fluid3D([16604,16055,16607,16614],0); -ELEMENTS[47411] = Fluid3D([13745,14396,14174,14735],0); -ELEMENTS[47412] = Fluid3D([11219,11664,10570,10962],0); -ELEMENTS[47413] = Fluid3D([10363,10813,9966,11316],0); -ELEMENTS[47414] = Fluid3D([13514,12893,13621,12830],0); -ELEMENTS[47415] = Fluid3D([4661,4629,5212,4763],0); -ELEMENTS[47416] = Fluid3D([17207,17529,17680,17611],0); -ELEMENTS[47417] = Fluid3D([7497,7794,7016,7740],0); -ELEMENTS[47418] = Fluid3D([7794,7016,7740,7543],0); -ELEMENTS[47419] = Fluid3D([7016,7740,7543,7061],0); -ELEMENTS[47420] = Fluid3D([7016,7740,7061,6714],0); -ELEMENTS[47421] = Fluid3D([7543,7016,7061,6449],0); -ELEMENTS[47422] = Fluid3D([7740,7543,7061,8209],0); -ELEMENTS[47423] = Fluid3D([7740,7543,8209,8649],0); -ELEMENTS[47424] = Fluid3D([7794,7016,7543,7124],0); -ELEMENTS[47425] = Fluid3D([7016,7061,6449,6714],0); -ELEMENTS[47426] = Fluid3D([7740,7794,7543,8649],0); -ELEMENTS[47427] = Fluid3D([7016,7497,7740,6714],0); -ELEMENTS[47428] = Fluid3D([7497,7794,7740,8877],0); -ELEMENTS[47429] = Fluid3D([4262,4623,4915,4528],0); -ELEMENTS[47430] = Fluid3D([4623,4915,4528,4711],0); -ELEMENTS[47431] = Fluid3D([7497,7285,8097,6992],0); -ELEMENTS[47432] = Fluid3D([7285,8097,6992,7569],0); -ELEMENTS[47433] = Fluid3D([7497,7285,6992,6437],0); -ELEMENTS[47434] = Fluid3D([6991,6255,6535,7274],0); -ELEMENTS[47435] = Fluid3D([4243,4068,3851,3907],0); -ELEMENTS[47436] = Fluid3D([14002,14443,14288,13676],0); -ELEMENTS[47437] = Fluid3D([14288,14002,13676,13843],0); -ELEMENTS[47438] = Fluid3D([13676,14288,13843,13867],0); -ELEMENTS[47439] = Fluid3D([13676,14288,13867,13695],0); -ELEMENTS[47440] = Fluid3D([13676,14288,13695,13896],0); -ELEMENTS[47441] = Fluid3D([8147,8674,8027,9148],0); -ELEMENTS[47442] = Fluid3D([8147,8674,9148,8765],0); -ELEMENTS[47443] = Fluid3D([4830,4783,5347,5355],0); -ELEMENTS[47444] = Fluid3D([7288,7780,7234,6467],0); -ELEMENTS[47445] = Fluid3D([18061,18195,17895,18133],0); -ELEMENTS[47446] = Fluid3D([18061,18195,18133,18261],0); -ELEMENTS[47447] = Fluid3D([18195,18133,18261,18400],0); -ELEMENTS[47448] = Fluid3D([4424,4700,5202,4641],0); -ELEMENTS[47449] = Fluid3D([16528,16058,16326,16461],0); -ELEMENTS[47450] = Fluid3D([13778,14018,13575,13030],0); -ELEMENTS[47451] = Fluid3D([14454,15186,15341,15016],0); -ELEMENTS[47452] = Fluid3D([15186,15341,15016,15438],0); -ELEMENTS[47453] = Fluid3D([16074,15488,16105,15655],0); -ELEMENTS[47454] = Fluid3D([1889,2006,1910,2118],0); -ELEMENTS[47455] = Fluid3D([2670,3043,2927,2705],0); -ELEMENTS[47456] = Fluid3D([5652,6305,6189,6152],0); -ELEMENTS[47457] = Fluid3D([14118,13829,14471,14068],0); -ELEMENTS[47458] = Fluid3D([3958,4465,4051,4150],0); -ELEMENTS[47459] = Fluid3D([8622,8300,9228,8355],0); -ELEMENTS[47460] = Fluid3D([4769,4429,5035,4893],0); -ELEMENTS[47461] = Fluid3D([6334,6542,7191,6574],0); -ELEMENTS[47462] = Fluid3D([10116,9529,10211,10673],0); -ELEMENTS[47463] = Fluid3D([8258,9005,8726,9457],0); -ELEMENTS[47464] = Fluid3D([16444,16115,16286,16763],0); -ELEMENTS[47465] = Fluid3D([17253,17692,17435,17535],0); -ELEMENTS[47466] = Fluid3D([16801,17174,16779,17095],0); -ELEMENTS[47467] = Fluid3D([16801,17174,17095,17291],0); -ELEMENTS[47468] = Fluid3D([17174,16779,17095,17225],0); -ELEMENTS[47469] = Fluid3D([17095,16801,17291,17180],0); -ELEMENTS[47470] = Fluid3D([17174,17095,17291,17380],0); -ELEMENTS[47471] = Fluid3D([17095,17291,17380,17180],0); -ELEMENTS[47472] = Fluid3D([2846,3137,2747,3009],0); -ELEMENTS[47473] = Fluid3D([6809,7297,6568,6828],0); -ELEMENTS[47474] = Fluid3D([7297,6568,6828,7154],0); -ELEMENTS[47475] = Fluid3D([13715,13332,13193,12373],0); -ELEMENTS[47476] = Fluid3D([2398,2637,2464,2394],0); -ELEMENTS[47477] = Fluid3D([8968,8444,8063,7828],0); -ELEMENTS[47478] = Fluid3D([18037,18223,18107,18328],0); -ELEMENTS[47479] = Fluid3D([18223,18107,18328,18132],0); -ELEMENTS[47480] = Fluid3D([10250,10881,10958,10102],0); -ELEMENTS[47481] = Fluid3D([10250,10881,10102,9950],0); -ELEMENTS[47482] = Fluid3D([16723,16407,16671,16751],0); -ELEMENTS[47483] = Fluid3D([16407,16671,16751,16396],0); -ELEMENTS[47484] = Fluid3D([16751,16407,16396,16793],0); -ELEMENTS[47485] = Fluid3D([16741,16235,16311,16146],0); -ELEMENTS[47486] = Fluid3D([8806,8897,8468,7616],0); -ELEMENTS[47487] = Fluid3D([9959,9629,9061,8820],0); -ELEMENTS[47488] = Fluid3D([8219,8406,7488,8007],0); -ELEMENTS[47489] = Fluid3D([11557,12386,12114,12579],0); -ELEMENTS[47490] = Fluid3D([12114,11557,12579,11779],0); -ELEMENTS[47491] = Fluid3D([15892,16152,15508,16299],0); -ELEMENTS[47492] = Fluid3D([16152,15508,16299,16266],0); -ELEMENTS[47493] = Fluid3D([16299,16152,16266,16663],0); -ELEMENTS[47494] = Fluid3D([15892,16152,16299,16555],0); -ELEMENTS[47495] = Fluid3D([16152,16299,16555,16663],0); -ELEMENTS[47496] = Fluid3D([7977,8091,7935,7221],0); -ELEMENTS[47497] = Fluid3D([7935,7977,7221,8146],0); -ELEMENTS[47498] = Fluid3D([7935,7977,8146,8967],0); -ELEMENTS[47499] = Fluid3D([18417,18207,18296,18389],0); -ELEMENTS[47500] = Fluid3D([18296,18417,18389,18473],0); -ELEMENTS[47501] = Fluid3D([18389,18296,18473,18436],0); -ELEMENTS[47502] = Fluid3D([18296,18417,18473,18388],0); -ELEMENTS[47503] = Fluid3D([18417,18389,18473,18492],0); -ELEMENTS[47504] = Fluid3D([18389,18473,18492,18436],0); -ELEMENTS[47505] = Fluid3D([18492,18389,18436,18443],0); -ELEMENTS[47506] = Fluid3D([18207,18296,18389,18244],0); -ELEMENTS[47507] = Fluid3D([18296,18389,18244,18436],0); -ELEMENTS[47508] = Fluid3D([18389,18244,18436,18443],0); -ELEMENTS[47509] = Fluid3D([18417,18389,18492,18422],0); -ELEMENTS[47510] = Fluid3D([18389,18492,18422,18360],0); -ELEMENTS[47511] = Fluid3D([18389,18492,18360,18443],0); -ELEMENTS[47512] = Fluid3D([18417,18389,18422,18207],0); -ELEMENTS[47513] = Fluid3D([18422,18389,18360,18207],0); -ELEMENTS[47514] = Fluid3D([18389,18207,18244,18360],0); -ELEMENTS[47515] = Fluid3D([6468,7283,6900,6968],0); -ELEMENTS[47516] = Fluid3D([6468,7283,6968,6970],0); -ELEMENTS[47517] = Fluid3D([2448,2594,2727,2518],0); -ELEMENTS[47518] = Fluid3D([4465,4669,4209,4150],0); -ELEMENTS[47519] = Fluid3D([18652,18620,18673,18660],0); -ELEMENTS[47520] = Fluid3D([18652,18620,18660,18574],0); -ELEMENTS[47521] = Fluid3D([18673,18652,18660,18682],0); -ELEMENTS[47522] = Fluid3D([18652,18660,18682,18657],0); -ELEMENTS[47523] = Fluid3D([6447,6352,5761,6253],0); -ELEMENTS[47524] = Fluid3D([6370,6192,7171,7133],0); -ELEMENTS[47525] = Fluid3D([14003,14675,13964,14837],0); -ELEMENTS[47526] = Fluid3D([2167,2282,2179,2234],0); -ELEMENTS[47527] = Fluid3D([2179,2167,2234,1955],0); -ELEMENTS[47528] = Fluid3D([12410,12490,12976,13279],0); -ELEMENTS[47529] = Fluid3D([16534,16113,16334,16688],0); -ELEMENTS[47530] = Fluid3D([8094,7600,8467,8231],0); -ELEMENTS[47531] = Fluid3D([4241,4180,3784,3640],0); -ELEMENTS[47532] = Fluid3D([7730,8411,8832,8151],0); -ELEMENTS[47533] = Fluid3D([6606,6479,6376,7411],0); -ELEMENTS[47534] = Fluid3D([9935,10432,9274,10372],0); -ELEMENTS[47535] = Fluid3D([13210,13597,13490,14069],0); -ELEMENTS[47536] = Fluid3D([13597,13490,14069,14274],0); -ELEMENTS[47537] = Fluid3D([14069,13597,14274,14642],0); -ELEMENTS[47538] = Fluid3D([13210,13597,14069,13947],0); -ELEMENTS[47539] = Fluid3D([5194,4646,5084,5320],0); -ELEMENTS[47540] = Fluid3D([7450,7069,8116,6923],0); -ELEMENTS[47541] = Fluid3D([15496,15445,16050,15917],0); -ELEMENTS[47542] = Fluid3D([8001,8184,8580,7668],0); -ELEMENTS[47543] = Fluid3D([12528,12818,12153,11839],0); -ELEMENTS[47544] = Fluid3D([12708,12916,13344,12453],0); -ELEMENTS[47545] = Fluid3D([13344,12708,12453,12743],0); -ELEMENTS[47546] = Fluid3D([13344,12708,12743,13635],0); -ELEMENTS[47547] = Fluid3D([17348,17286,17298,16944],0); -ELEMENTS[47548] = Fluid3D([17298,17348,16944,17439],0); -ELEMENTS[47549] = Fluid3D([17298,17348,17439,17667],0); -ELEMENTS[47550] = Fluid3D([17348,17439,17667,17629],0); -ELEMENTS[47551] = Fluid3D([17348,17439,17629,17041],0); -ELEMENTS[47552] = Fluid3D([17298,17348,17667,17647],0); -ELEMENTS[47553] = Fluid3D([17348,17667,17647,17629],0); -ELEMENTS[47554] = Fluid3D([17667,17647,17629,18032],0); -ELEMENTS[47555] = Fluid3D([17647,17348,17629,17589],0); -ELEMENTS[47556] = Fluid3D([17439,17667,17629,17927],0); -ELEMENTS[47557] = Fluid3D([17348,16944,17439,17041],0); -ELEMENTS[47558] = Fluid3D([17629,17647,17589,17921],0); -ELEMENTS[47559] = Fluid3D([17589,17629,17921,17934],0); -ELEMENTS[47560] = Fluid3D([17589,17629,17934,17505],0); -ELEMENTS[47561] = Fluid3D([17921,17589,17934,17789],0); -ELEMENTS[47562] = Fluid3D([17589,17934,17789,17678],0); -ELEMENTS[47563] = Fluid3D([17934,17789,17678,17961],0); -ELEMENTS[47564] = Fluid3D([17678,17934,17961,17505],0); -ELEMENTS[47565] = Fluid3D([17439,17298,17667,17927],0); -ELEMENTS[47566] = Fluid3D([15691,15419,16265,15867],0); -ELEMENTS[47567] = Fluid3D([12843,13657,12981,12745],0); -ELEMENTS[47568] = Fluid3D([5997,5660,6566,5956],0); -ELEMENTS[47569] = Fluid3D([5997,5660,5956,5342],0); -ELEMENTS[47570] = Fluid3D([12532,12009,12176,13227],0); -ELEMENTS[47571] = Fluid3D([15523,15390,16026,16092],0); -ELEMENTS[47572] = Fluid3D([2531,2292,2483,2527],0); -ELEMENTS[47573] = Fluid3D([16384,16720,16876,16931],0); -ELEMENTS[47574] = Fluid3D([2187,2137,2235,2453],0); -ELEMENTS[47575] = Fluid3D([4009,4368,3990,4443],0); -ELEMENTS[47576] = Fluid3D([6430,6817,7157,6722],0); -ELEMENTS[47577] = Fluid3D([9936,9675,9164,8653],0); -ELEMENTS[47578] = Fluid3D([7900,8542,8491,8764],0); -ELEMENTS[47579] = Fluid3D([6554,7143,6938,7730],0); -ELEMENTS[47580] = Fluid3D([6554,7143,7730,7657],0); -ELEMENTS[47581] = Fluid3D([12348,12645,13268,12761],0); -ELEMENTS[47582] = Fluid3D([18608,18518,18614,18629],0); -ELEMENTS[47583] = Fluid3D([18614,18608,18629,18649],0); -ELEMENTS[47584] = Fluid3D([18608,18629,18649,18666],0); -ELEMENTS[47585] = Fluid3D([18629,18649,18666,18669],0); -ELEMENTS[47586] = Fluid3D([18629,18614,18649,18643],0); -ELEMENTS[47587] = Fluid3D([18629,18649,18669,18643],0); -ELEMENTS[47588] = Fluid3D([18649,18608,18666,18662],0); -ELEMENTS[47589] = Fluid3D([18666,18649,18662,18686],0); -ELEMENTS[47590] = Fluid3D([18666,18649,18686,18669],0); -ELEMENTS[47591] = Fluid3D([18649,18686,18669,18670],0); -ELEMENTS[47592] = Fluid3D([18649,18686,18670,18662],0); -ELEMENTS[47593] = Fluid3D([18670,18649,18662,18643],0); -ELEMENTS[47594] = Fluid3D([18686,18669,18670,18675],0); -ELEMENTS[47595] = Fluid3D([18669,18670,18675,18643],0); -ELEMENTS[47596] = Fluid3D([18670,18675,18643,18677],0); -ELEMENTS[47597] = Fluid3D([18643,18670,18677,18662],0); -ELEMENTS[47598] = Fluid3D([18670,18677,18662,18686],0); -ELEMENTS[47599] = Fluid3D([18669,18649,18670,18643],0); -ELEMENTS[47600] = Fluid3D([17264,17342,17160,16947],0); -ELEMENTS[47601] = Fluid3D([7894,8399,8910,8228],0); -ELEMENTS[47602] = Fluid3D([15248,15193,15076,14447],0); -ELEMENTS[47603] = Fluid3D([15076,15248,14447,15143],0); -ELEMENTS[47604] = Fluid3D([15248,14447,15143,14691],0); -ELEMENTS[47605] = Fluid3D([15076,15248,15143,15580],0); -ELEMENTS[47606] = Fluid3D([8883,8425,9082,8093],0); -ELEMENTS[47607] = Fluid3D([8425,9082,8093,8847],0); -ELEMENTS[47608] = Fluid3D([8093,8425,8847,7863],0); -ELEMENTS[47609] = Fluid3D([4255,4608,4701,4558],0); -ELEMENTS[47610] = Fluid3D([17503,17276,17686,17131],0); -ELEMENTS[47611] = Fluid3D([3881,4393,4208,4225],0); -ELEMENTS[47612] = Fluid3D([16268,15928,16360,16135],0); -ELEMENTS[47613] = Fluid3D([15928,16360,16135,15831],0); -ELEMENTS[47614] = Fluid3D([16268,15928,16135,15563],0); -ELEMENTS[47615] = Fluid3D([2422,2367,2484,2326],0); -ELEMENTS[47616] = Fluid3D([9070,8187,8169,8333],0); -ELEMENTS[47617] = Fluid3D([16607,16652,16852,16347],0); -ELEMENTS[47618] = Fluid3D([16607,16652,16347,15893],0); -ELEMENTS[47619] = Fluid3D([13792,13825,14640,14018],0); -ELEMENTS[47620] = Fluid3D([14283,14858,14027,13754],0); -ELEMENTS[47621] = Fluid3D([14960,14423,14142,13842],0); -ELEMENTS[47622] = Fluid3D([18681,18689,18678,18694],0); -ELEMENTS[47623] = Fluid3D([18678,18681,18694,18680],0); -ELEMENTS[47624] = Fluid3D([2223,2269,2081,2018],0); -ELEMENTS[47625] = Fluid3D([5802,6540,6347,6650],0); -ELEMENTS[47626] = Fluid3D([6540,6347,6650,7213],0); -ELEMENTS[47627] = Fluid3D([12240,12919,12445,12903],0); -ELEMENTS[47628] = Fluid3D([14195,14523,14613,13691],0); -ELEMENTS[47629] = Fluid3D([16634,16795,17084,17077],0); -ELEMENTS[47630] = Fluid3D([5037,4761,4637,4324],0); -ELEMENTS[47631] = Fluid3D([10049,10324,10363,9205],0); -ELEMENTS[47632] = Fluid3D([2911,3244,3037,3197],0); -ELEMENTS[47633] = Fluid3D([16659,16780,16620,16980],0); -ELEMENTS[47634] = Fluid3D([16620,16659,16980,16789],0); -ELEMENTS[47635] = Fluid3D([16659,16780,16980,17164],0); -ELEMENTS[47636] = Fluid3D([13973,13158,13683,13499],0); -ELEMENTS[47637] = Fluid3D([5090,5047,4485,4731],0); -ELEMENTS[47638] = Fluid3D([7294,7452,7584,6790],0); -ELEMENTS[47639] = Fluid3D([7294,7452,6790,6653],0); -ELEMENTS[47640] = Fluid3D([7584,7294,6790,7558],0); -ELEMENTS[47641] = Fluid3D([7294,6790,7558,6924],0); -ELEMENTS[47642] = Fluid3D([7294,6790,6924,6653],0); -ELEMENTS[47643] = Fluid3D([12250,11533,11268,11634],0); -ELEMENTS[47644] = Fluid3D([15435,15685,16156,15769],0); -ELEMENTS[47645] = Fluid3D([15685,16156,15769,15932],0); -ELEMENTS[47646] = Fluid3D([15685,16156,15932,16329],0); -ELEMENTS[47647] = Fluid3D([15769,15685,15932,15518],0); -ELEMENTS[47648] = Fluid3D([16403,16702,17015,16457],0); -ELEMENTS[47649] = Fluid3D([12835,12668,13377,13124],0); -ELEMENTS[47650] = Fluid3D([10723,11348,11954,11666],0); -ELEMENTS[47651] = Fluid3D([14335,14021,13499,13804],0); -ELEMENTS[47652] = Fluid3D([4737,4467,4219,4324],0); -ELEMENTS[47653] = Fluid3D([4219,4737,4324,4091],0); -ELEMENTS[47654] = Fluid3D([14274,14707,14642,13597],0); -ELEMENTS[47655] = Fluid3D([17229,16910,17376,17025],0); -ELEMENTS[47656] = Fluid3D([17376,17229,17025,17621],0); -ELEMENTS[47657] = Fluid3D([17229,16910,17025,16769],0); -ELEMENTS[47658] = Fluid3D([17025,17229,16769,17286],0); -ELEMENTS[47659] = Fluid3D([15111,15423,15764,15551],0); -ELEMENTS[47660] = Fluid3D([1717,1723,1625,1641],0); -ELEMENTS[47661] = Fluid3D([1717,1723,1641,1728],0); -ELEMENTS[47662] = Fluid3D([1723,1625,1641,1621],0); -ELEMENTS[47663] = Fluid3D([1723,1641,1728,1727],0); -ELEMENTS[47664] = Fluid3D([7351,7306,7086,7983],0); -ELEMENTS[47665] = Fluid3D([7306,7086,7983,7958],0); -ELEMENTS[47666] = Fluid3D([7086,7351,7983,7539],0); -ELEMENTS[47667] = Fluid3D([7351,7306,7983,7966],0); -ELEMENTS[47668] = Fluid3D([17879,17812,17706,18035],0); -ELEMENTS[47669] = Fluid3D([2634,2652,2733,2451],0); -ELEMENTS[47670] = Fluid3D([2634,2652,2451,2389],0); -ELEMENTS[47671] = Fluid3D([2451,2634,2389,2749],0); -ELEMENTS[47672] = Fluid3D([17905,18090,18203,18217],0); -ELEMENTS[47673] = Fluid3D([11089,11923,11148,11079],0); -ELEMENTS[47674] = Fluid3D([11089,11923,11079,11498],0); -ELEMENTS[47675] = Fluid3D([7465,7402,6615,6984],0); -ELEMENTS[47676] = Fluid3D([7465,7402,6984,8246],0); -ELEMENTS[47677] = Fluid3D([4740,5277,4771,4708],0); -ELEMENTS[47678] = Fluid3D([12712,12875,12148,11746],0); -ELEMENTS[47679] = Fluid3D([12712,12875,11746,12343],0); -ELEMENTS[47680] = Fluid3D([14255,14867,14564,14868],0); -ELEMENTS[47681] = Fluid3D([10957,11931,10959,11820],0); -ELEMENTS[47682] = Fluid3D([7714,7510,7096,7970],0); -ELEMENTS[47683] = Fluid3D([13646,13961,14328,14763],0); -ELEMENTS[47684] = Fluid3D([13961,14328,14763,14794],0); -ELEMENTS[47685] = Fluid3D([13961,14328,14794,14385],0); -ELEMENTS[47686] = Fluid3D([4445,4306,4092,4308],0); -ELEMENTS[47687] = Fluid3D([4445,4306,4308,4922],0); -ELEMENTS[47688] = Fluid3D([16286,16115,16484,16763],0); -ELEMENTS[47689] = Fluid3D([16484,16286,16763,16146],0); -ELEMENTS[47690] = Fluid3D([18258,18361,18482,18372],0); -ELEMENTS[47691] = Fluid3D([18258,18361,18372,18227],0); -ELEMENTS[47692] = Fluid3D([18258,18361,18227,18137],0); -ELEMENTS[47693] = Fluid3D([18227,18258,18137,18196],0); -ELEMENTS[47694] = Fluid3D([18258,18361,18137,18154],0); -ELEMENTS[47695] = Fluid3D([18258,18137,18196,17947],0); -ELEMENTS[47696] = Fluid3D([18361,18227,18137,18221],0); -ELEMENTS[47697] = Fluid3D([18258,18137,17947,18154],0); -ELEMENTS[47698] = Fluid3D([18372,18258,18227,18196],0); -ELEMENTS[47699] = Fluid3D([18372,18258,18196,18279],0); -ELEMENTS[47700] = Fluid3D([18258,18196,18279,17947],0); -ELEMENTS[47701] = Fluid3D([11285,11098,10386,11083],0); -ELEMENTS[47702] = Fluid3D([11098,10386,11083,11460],0); -ELEMENTS[47703] = Fluid3D([14463,14648,14902,15137],0); -ELEMENTS[47704] = Fluid3D([14902,14463,15137,15082],0); -ELEMENTS[47705] = Fluid3D([14881,14105,14688,14097],0); -ELEMENTS[47706] = Fluid3D([3793,3551,3616,3802],0); -ELEMENTS[47707] = Fluid3D([17683,17862,18043,17846],0); -ELEMENTS[47708] = Fluid3D([17683,17862,17846,17628],0); -ELEMENTS[47709] = Fluid3D([16426,16732,16372,16389],0); -ELEMENTS[47710] = Fluid3D([8947,9601,9712,9120],0); -ELEMENTS[47711] = Fluid3D([11350,12237,11656,11233],0); -ELEMENTS[47712] = Fluid3D([5391,5148,4801,5509],0); -ELEMENTS[47713] = Fluid3D([5391,5148,5509,5476],0); -ELEMENTS[47714] = Fluid3D([6713,6955,6796,6300],0); -ELEMENTS[47715] = Fluid3D([6713,6955,6300,6320],0); -ELEMENTS[47716] = Fluid3D([6713,6955,6320,7401],0); -ELEMENTS[47717] = Fluid3D([10729,11292,10631,11407],0); -ELEMENTS[47718] = Fluid3D([15726,15822,16207,15999],0); -ELEMENTS[47719] = Fluid3D([16198,15794,15825,16425],0); -ELEMENTS[47720] = Fluid3D([15344,15394,15178,14488],0); -ELEMENTS[47721] = Fluid3D([2876,2500,2767,2588],0); -ELEMENTS[47722] = Fluid3D([8668,8968,8915,8021],0); -ELEMENTS[47723] = Fluid3D([10865,10158,11395,10800],0); -ELEMENTS[47724] = Fluid3D([11553,11691,12529,11618],0); -ELEMENTS[47725] = Fluid3D([7707,6960,7354,7928],0); -ELEMENTS[47726] = Fluid3D([6158,6401,6517,5738],0); -ELEMENTS[47727] = Fluid3D([9156,8424,9083,8134],0); -ELEMENTS[47728] = Fluid3D([9368,8951,8332,9239],0); -ELEMENTS[47729] = Fluid3D([8951,8332,9239,9020],0); -ELEMENTS[47730] = Fluid3D([9368,8951,9239,10112],0); -ELEMENTS[47731] = Fluid3D([14657,14994,15049,15261],0); -ELEMENTS[47732] = Fluid3D([15743,15430,15173,15832],0); -ELEMENTS[47733] = Fluid3D([15430,15173,15832,15383],0); -ELEMENTS[47734] = Fluid3D([15173,15832,15383,15439],0); -ELEMENTS[47735] = Fluid3D([15430,15173,15383,14627],0); -ELEMENTS[47736] = Fluid3D([14122,13944,14685,14599],0); -ELEMENTS[47737] = Fluid3D([16772,17120,16994,16465],0); -ELEMENTS[47738] = Fluid3D([13863,13582,13123,14164],0); -ELEMENTS[47739] = Fluid3D([8815,8550,8353,9174],0); -ELEMENTS[47740] = Fluid3D([8027,8142,8180,7477],0); -ELEMENTS[47741] = Fluid3D([8027,8142,7477,7328],0); -ELEMENTS[47742] = Fluid3D([8180,8027,7477,7807],0); -ELEMENTS[47743] = Fluid3D([8027,7477,7807,7257],0); -ELEMENTS[47744] = Fluid3D([7477,8027,7328,7123],0); -ELEMENTS[47745] = Fluid3D([11380,11636,11546,10746],0); -ELEMENTS[47746] = Fluid3D([15988,16140,16337,15897],0); -ELEMENTS[47747] = Fluid3D([17839,17721,17619,18067],0); -ELEMENTS[47748] = Fluid3D([11097,11458,10558,10887],0); -ELEMENTS[47749] = Fluid3D([2495,2546,2517,2899],0); -ELEMENTS[47750] = Fluid3D([11789,11713,12586,11542],0); -ELEMENTS[47751] = Fluid3D([8499,8449,8081,7840],0); -ELEMENTS[47752] = Fluid3D([17788,18132,17999,17933],0); -ELEMENTS[47753] = Fluid3D([13645,13758,12555,13575],0); -ELEMENTS[47754] = Fluid3D([13645,13758,13575,14375],0); -ELEMENTS[47755] = Fluid3D([13758,13575,14375,14393],0); -ELEMENTS[47756] = Fluid3D([15520,15604,16041,15302],0); -ELEMENTS[47757] = Fluid3D([1791,1759,1664,1698],0); -ELEMENTS[47758] = Fluid3D([12326,12761,11609,12348],0); -ELEMENTS[47759] = Fluid3D([15877,16389,16201,16294],0); -ELEMENTS[47760] = Fluid3D([16389,16201,16294,16966],0); -ELEMENTS[47761] = Fluid3D([16201,15877,16294,15927],0); -ELEMENTS[47762] = Fluid3D([15877,16389,16294,16426],0); -ELEMENTS[47763] = Fluid3D([11986,11311,12307,12040],0); -ELEMENTS[47764] = Fluid3D([11311,12307,12040,11552],0); -ELEMENTS[47765] = Fluid3D([12307,11986,12040,13196],0); -ELEMENTS[47766] = Fluid3D([11986,11311,12040,11048],0); -ELEMENTS[47767] = Fluid3D([15622,16013,16240,15651],0); -ELEMENTS[47768] = Fluid3D([6156,6664,5985,6718],0); -ELEMENTS[47769] = Fluid3D([9697,9149,10057,8908],0); -ELEMENTS[47770] = Fluid3D([14278,14555,13770,14337],0); -ELEMENTS[47771] = Fluid3D([15497,15485,15246,15962],0); -ELEMENTS[47772] = Fluid3D([5642,5146,5998,5469],0); -ELEMENTS[47773] = Fluid3D([5998,5642,5469,5667],0); -ELEMENTS[47774] = Fluid3D([5469,5998,5667,5926],0); -ELEMENTS[47775] = Fluid3D([5469,5998,5926,5452],0); -ELEMENTS[47776] = Fluid3D([5642,5469,5667,5146],0); -ELEMENTS[47777] = Fluid3D([4253,4862,4436,4802],0); -ELEMENTS[47778] = Fluid3D([17437,17711,17768,17603],0); -ELEMENTS[47779] = Fluid3D([10367,10299,10925,11667],0); -ELEMENTS[47780] = Fluid3D([15036,15318,14500,15567],0); -ELEMENTS[47781] = Fluid3D([15036,15318,15567,15852],0); -ELEMENTS[47782] = Fluid3D([12079,12181,11366,11246],0); -ELEMENTS[47783] = Fluid3D([2743,2771,2578,2792],0); -ELEMENTS[47784] = Fluid3D([2578,2743,2792,2468],0); -ELEMENTS[47785] = Fluid3D([2771,2578,2792,2504],0); -ELEMENTS[47786] = Fluid3D([2578,2792,2504,2609],0); -ELEMENTS[47787] = Fluid3D([2578,2792,2609,2619],0); -ELEMENTS[47788] = Fluid3D([2609,2578,2619,2468],0); -ELEMENTS[47789] = Fluid3D([2619,2609,2468,2577],0); -ELEMENTS[47790] = Fluid3D([2468,2619,2577,2828],0); -ELEMENTS[47791] = Fluid3D([2619,2609,2577,2828],0); -ELEMENTS[47792] = Fluid3D([2468,2619,2828,2792],0); -ELEMENTS[47793] = Fluid3D([2792,2609,2619,2828],0); -ELEMENTS[47794] = Fluid3D([2578,2792,2619,2468],0); -ELEMENTS[47795] = Fluid3D([2504,2578,2609,2344],0); -ELEMENTS[47796] = Fluid3D([13333,12761,13612,12484],0); -ELEMENTS[47797] = Fluid3D([14541,15073,15463,15234],0); -ELEMENTS[47798] = Fluid3D([6111,5958,6097,5475],0); -ELEMENTS[47799] = Fluid3D([9319,8344,9119,9113],0); -ELEMENTS[47800] = Fluid3D([16825,16706,16379,16002],0); -ELEMENTS[47801] = Fluid3D([3168,2870,3245,2819],0); -ELEMENTS[47802] = Fluid3D([5565,6182,5752,5716],0); -ELEMENTS[47803] = Fluid3D([5752,5565,5716,5409],0); -ELEMENTS[47804] = Fluid3D([5716,5752,5409,6034],0); -ELEMENTS[47805] = Fluid3D([5409,5716,6034,5449],0); -ELEMENTS[47806] = Fluid3D([5565,6182,5716,5754],0); -ELEMENTS[47807] = Fluid3D([5716,5752,6034,6182],0); -ELEMENTS[47808] = Fluid3D([5565,5716,5409,5215],0); -ELEMENTS[47809] = Fluid3D([5565,5716,5215,5754],0); -ELEMENTS[47810] = Fluid3D([5716,6034,5449,6284],0); -ELEMENTS[47811] = Fluid3D([5716,6034,6284,6182],0); -ELEMENTS[47812] = Fluid3D([6284,5716,6182,5754],0); -ELEMENTS[47813] = Fluid3D([14280,13829,13921,13274],0); -ELEMENTS[47814] = Fluid3D([14280,13829,13274,13951],0); -ELEMENTS[47815] = Fluid3D([14280,13829,13951,14068],0); -ELEMENTS[47816] = Fluid3D([12278,11445,11853,12734],0); -ELEMENTS[47817] = Fluid3D([11153,10576,11055,11046],0); -ELEMENTS[47818] = Fluid3D([11055,11153,11046,11962],0); -ELEMENTS[47819] = Fluid3D([11153,10576,11046,11232],0); -ELEMENTS[47820] = Fluid3D([11046,11153,11232,11962],0); -ELEMENTS[47821] = Fluid3D([11509,12428,12245,11838],0); -ELEMENTS[47822] = Fluid3D([14586,14118,13986,14050],0); -ELEMENTS[47823] = Fluid3D([14586,14118,14050,13682],0); -ELEMENTS[47824] = Fluid3D([18416,18477,18531,18298],0); -ELEMENTS[47825] = Fluid3D([14315,14102,13891,14595],0); -ELEMENTS[47826] = Fluid3D([17541,17223,17390,17112],0); -ELEMENTS[47827] = Fluid3D([17541,17223,17112,17276],0); -ELEMENTS[47828] = Fluid3D([2532,2593,2820,2910],0); -ELEMENTS[47829] = Fluid3D([14634,15290,15552,15170],0); -ELEMENTS[47830] = Fluid3D([10862,12043,11138,10652],0); -ELEMENTS[47831] = Fluid3D([11138,10862,10652,10874],0); -ELEMENTS[47832] = Fluid3D([10652,11138,10874,11424],0); -ELEMENTS[47833] = Fluid3D([10652,11138,11424,12043],0); -ELEMENTS[47834] = Fluid3D([11138,10874,11424,12043],0); -ELEMENTS[47835] = Fluid3D([13459,14121,13796,14295],0); -ELEMENTS[47836] = Fluid3D([4444,4032,3955,4286],0); -ELEMENTS[47837] = Fluid3D([17465,17567,17213,17161],0); -ELEMENTS[47838] = Fluid3D([17213,17465,17161,17042],0); -ELEMENTS[47839] = Fluid3D([17567,17213,17161,17270],0); -ELEMENTS[47840] = Fluid3D([4009,3542,3966,3769],0); -ELEMENTS[47841] = Fluid3D([3542,3966,3769,3299],0); -ELEMENTS[47842] = Fluid3D([3966,4009,3769,3990],0); -ELEMENTS[47843] = Fluid3D([13265,13008,12644,11748],0); -ELEMENTS[47844] = Fluid3D([16289,15998,16416,16617],0); -ELEMENTS[47845] = Fluid3D([2997,2742,2718,2905],0); -ELEMENTS[47846] = Fluid3D([2997,2742,2905,2870],0); -ELEMENTS[47847] = Fluid3D([2742,2905,2870,2512],0); -ELEMENTS[47848] = Fluid3D([6403,6205,5593,5707],0); -ELEMENTS[47849] = Fluid3D([13892,14055,14510,14265],0); -ELEMENTS[47850] = Fluid3D([2609,2720,2586,2423],0); -ELEMENTS[47851] = Fluid3D([5802,6347,6046,5891],0); -ELEMENTS[47852] = Fluid3D([5802,6347,5891,6650],0); -ELEMENTS[47853] = Fluid3D([6347,6046,5891,6534],0); -ELEMENTS[47854] = Fluid3D([6347,6046,6534,6765],0); -ELEMENTS[47855] = Fluid3D([5891,6347,6534,6650],0); -ELEMENTS[47856] = Fluid3D([16488,16582,16623,17007],0); -ELEMENTS[47857] = Fluid3D([5084,5218,5793,5598],0); -ELEMENTS[47858] = Fluid3D([15317,15110,15704,15715],0); -ELEMENTS[47859] = Fluid3D([12429,12826,12754,13667],0); -ELEMENTS[47860] = Fluid3D([17724,17852,17462,17688],0); -ELEMENTS[47861] = Fluid3D([17462,17724,17688,17914],0); -ELEMENTS[47862] = Fluid3D([11453,11602,12319,11200],0); -ELEMENTS[47863] = Fluid3D([11453,11602,11200,10441],0); -ELEMENTS[47864] = Fluid3D([11200,11453,10441,11041],0); -ELEMENTS[47865] = Fluid3D([10441,11200,11041,11237],0); -ELEMENTS[47866] = Fluid3D([11200,11453,11041,12319],0); -ELEMENTS[47867] = Fluid3D([10782,11732,10757,11188],0); -ELEMENTS[47868] = Fluid3D([10757,10782,11188,9860],0); -ELEMENTS[47869] = Fluid3D([10757,10782,9860,10679],0); -ELEMENTS[47870] = Fluid3D([6817,6333,6080,6161],0); -ELEMENTS[47871] = Fluid3D([8265,8360,8863,7657],0); -ELEMENTS[47872] = Fluid3D([3680,3771,3288,3334],0); -ELEMENTS[47873] = Fluid3D([15594,15971,15794,15991],0); -ELEMENTS[47874] = Fluid3D([15794,15594,15991,15629],0); -ELEMENTS[47875] = Fluid3D([15594,15991,15629,15753],0); -ELEMENTS[47876] = Fluid3D([15594,15991,15753,15775],0); -ELEMENTS[47877] = Fluid3D([15991,15629,15753,16093],0); -ELEMENTS[47878] = Fluid3D([15753,15991,16093,16372],0); -ELEMENTS[47879] = Fluid3D([16093,15753,16372,15922],0); -ELEMENTS[47880] = Fluid3D([16372,16093,15922,15783],0); -ELEMENTS[47881] = Fluid3D([16093,15922,15783,15753],0); -ELEMENTS[47882] = Fluid3D([16372,16093,15783,16185],0); -ELEMENTS[47883] = Fluid3D([16093,15783,16185,16389],0); -ELEMENTS[47884] = Fluid3D([15922,16372,15783,16426],0); -ELEMENTS[47885] = Fluid3D([15922,15783,15753,15291],0); -ELEMENTS[47886] = Fluid3D([15783,16185,16389,15877],0); -ELEMENTS[47887] = Fluid3D([16372,16093,16185,16389],0); -ELEMENTS[47888] = Fluid3D([15783,16372,16185,16426],0); -ELEMENTS[47889] = Fluid3D([15783,16185,15877,16426],0); -ELEMENTS[47890] = Fluid3D([15783,16093,15753,15629],0); -ELEMENTS[47891] = Fluid3D([15783,16093,15629,16303],0); -ELEMENTS[47892] = Fluid3D([15783,16093,16303,16389],0); -ELEMENTS[47893] = Fluid3D([15753,16372,15922,15775],0); -ELEMENTS[47894] = Fluid3D([15922,15753,15775,15291],0); -ELEMENTS[47895] = Fluid3D([15753,16372,15775,15991],0); -ELEMENTS[47896] = Fluid3D([16185,16389,15877,16426],0); -ELEMENTS[47897] = Fluid3D([15783,15922,16426,15834],0); -ELEMENTS[47898] = Fluid3D([15783,15922,15834,15291],0); -ELEMENTS[47899] = Fluid3D([15922,16426,15834,16372],0); -ELEMENTS[47900] = Fluid3D([15834,15922,16372,15775],0); -ELEMENTS[47901] = Fluid3D([15991,16093,16372,16303],0); -ELEMENTS[47902] = Fluid3D([16093,16372,16303,16389],0); -ELEMENTS[47903] = Fluid3D([15834,15922,15775,15291],0); -ELEMENTS[47904] = Fluid3D([15753,15775,15291,15594],0); -ELEMENTS[47905] = Fluid3D([15991,15629,16093,16303],0); -ELEMENTS[47906] = Fluid3D([15594,15971,15991,15775],0); -ELEMENTS[47907] = Fluid3D([15629,15594,15753,15291],0); -ELEMENTS[47908] = Fluid3D([8364,7978,8340,7252],0); -ELEMENTS[47909] = Fluid3D([6432,6490,6679,7223],0); -ELEMENTS[47910] = Fluid3D([15829,16085,16384,16350],0); -ELEMENTS[47911] = Fluid3D([2928,3320,3148,2978],0); -ELEMENTS[47912] = Fluid3D([4767,4511,4116,4569],0); -ELEMENTS[47913] = Fluid3D([12877,13295,13051,12261],0); -ELEMENTS[47914] = Fluid3D([13224,13270,12427,12419],0); -ELEMENTS[47915] = Fluid3D([8591,8748,8073,7810],0); -ELEMENTS[47916] = Fluid3D([5921,6375,6201,5949],0); -ELEMENTS[47917] = Fluid3D([6375,6201,5949,6745],0); -ELEMENTS[47918] = Fluid3D([6201,5949,6745,5909],0); -ELEMENTS[47919] = Fluid3D([6201,5949,5909,5393],0); -ELEMENTS[47920] = Fluid3D([6201,5921,5949,5393],0); -ELEMENTS[47921] = Fluid3D([5516,5915,5316,5857],0); -ELEMENTS[47922] = Fluid3D([11117,11582,11254,12080],0); -ELEMENTS[47923] = Fluid3D([11254,11117,12080,12187],0); -ELEMENTS[47924] = Fluid3D([17714,17838,17710,18037],0); -ELEMENTS[47925] = Fluid3D([9977,10486,10952,9981],0); -ELEMENTS[47926] = Fluid3D([10486,10952,9981,10721],0); -ELEMENTS[47927] = Fluid3D([10486,10952,10721,11684],0); -ELEMENTS[47928] = Fluid3D([10422,11061,11160,10264],0); -ELEMENTS[47929] = Fluid3D([9143,9560,9855,9962],0); -ELEMENTS[47930] = Fluid3D([18178,17948,18148,18219],0); -ELEMENTS[47931] = Fluid3D([13588,13810,13536,14138],0); -ELEMENTS[47932] = Fluid3D([13536,13588,14138,13051],0); -ELEMENTS[47933] = Fluid3D([13588,14138,13051,14023],0); -ELEMENTS[47934] = Fluid3D([6411,6397,5883,6156],0); -ELEMENTS[47935] = Fluid3D([2289,2092,2222,2037],0); -ELEMENTS[47936] = Fluid3D([2109,1959,1995,1849],0); -ELEMENTS[47937] = Fluid3D([16146,16235,16642,16741],0); -ELEMENTS[47938] = Fluid3D([9015,8333,9463,9009],0); -ELEMENTS[47939] = Fluid3D([9015,8333,9009,9070],0); -ELEMENTS[47940] = Fluid3D([9015,8333,9070,8416],0); -ELEMENTS[47941] = Fluid3D([4037,4566,4278,4774],0); -ELEMENTS[47942] = Fluid3D([4566,4278,4774,4896],0); -ELEMENTS[47943] = Fluid3D([4774,4566,4896,5284],0); -ELEMENTS[47944] = Fluid3D([4037,4566,4774,4364],0); -ELEMENTS[47945] = Fluid3D([4566,4774,4364,4832],0); -ELEMENTS[47946] = Fluid3D([4566,4774,4832,5284],0); -ELEMENTS[47947] = Fluid3D([12920,13000,12577,13587],0); -ELEMENTS[47948] = Fluid3D([6415,5889,6370,6792],0); -ELEMENTS[47949] = Fluid3D([9401,9054,8709,8158],0); -ELEMENTS[47950] = Fluid3D([7703,8138,7193,8052],0); -ELEMENTS[47951] = Fluid3D([7703,8138,8052,8501],0); -ELEMENTS[47952] = Fluid3D([8138,8052,8501,9214],0); -ELEMENTS[47953] = Fluid3D([5228,4780,4644,4977],0); -ELEMENTS[47954] = Fluid3D([18615,18584,18510,18520],0); -ELEMENTS[47955] = Fluid3D([9910,10256,11187,10218],0); -ELEMENTS[47956] = Fluid3D([4242,3777,4171,3977],0); -ELEMENTS[47957] = Fluid3D([11422,11277,10488,11285],0); -ELEMENTS[47958] = Fluid3D([10116,10921,10429,9689],0); -ELEMENTS[47959] = Fluid3D([3596,3378,3629,3860],0); -ELEMENTS[47960] = Fluid3D([6896,6902,6224,7210],0); -ELEMENTS[47961] = Fluid3D([11351,10492,11483,10502],0); -ELEMENTS[47962] = Fluid3D([10492,11483,10502,10016],0); -ELEMENTS[47963] = Fluid3D([1870,1916,1922,1786],0); -ELEMENTS[47964] = Fluid3D([1870,1916,1786,1785],0); -ELEMENTS[47965] = Fluid3D([1916,1922,1786,1833],0); -ELEMENTS[47966] = Fluid3D([1916,1922,1833,1987],0); -ELEMENTS[47967] = Fluid3D([1922,1870,1786,1862],0); -ELEMENTS[47968] = Fluid3D([1870,1786,1862,1739],0); -ELEMENTS[47969] = Fluid3D([1870,1786,1739,1677],0); -ELEMENTS[47970] = Fluid3D([10410,10909,10207,11359],0); -ELEMENTS[47971] = Fluid3D([10422,10463,9828,9421],0); -ELEMENTS[47972] = Fluid3D([4540,4463,4858,5184],0); -ELEMENTS[47973] = Fluid3D([5659,6219,6068,5589],0); -ELEMENTS[47974] = Fluid3D([6068,5659,5589,5077],0); -ELEMENTS[47975] = Fluid3D([14973,15533,15146,15797],0); -ELEMENTS[47976] = Fluid3D([15533,15146,15797,15625],0); -ELEMENTS[47977] = Fluid3D([14973,15533,15797,15244],0); -ELEMENTS[47978] = Fluid3D([17682,17614,17867,18070],0); -ELEMENTS[47979] = Fluid3D([6248,5779,6126,5486],0); -ELEMENTS[47980] = Fluid3D([4987,4733,5201,5611],0); -ELEMENTS[47981] = Fluid3D([6483,7030,7096,6097],0); -ELEMENTS[47982] = Fluid3D([13930,14645,13811,13435],0); -ELEMENTS[47983] = Fluid3D([15699,15412,15845,16042],0); -ELEMENTS[47984] = Fluid3D([13848,14610,14368,13612],0); -ELEMENTS[47985] = Fluid3D([8670,9146,8778,8387],0); -ELEMENTS[47986] = Fluid3D([2794,2913,3181,3118],0); -ELEMENTS[47987] = Fluid3D([2794,2913,3118,2797],0); -ELEMENTS[47988] = Fluid3D([2794,2913,2797,2527],0); -ELEMENTS[47989] = Fluid3D([2913,3118,2797,2840],0); -ELEMENTS[47990] = Fluid3D([2797,2913,2840,2527],0); -ELEMENTS[47991] = Fluid3D([2840,2797,2527,2805],0); -ELEMENTS[47992] = Fluid3D([2840,2797,2805,3095],0); -ELEMENTS[47993] = Fluid3D([2840,2797,3095,3118],0); -ELEMENTS[47994] = Fluid3D([2797,3095,3118,2817],0); -ELEMENTS[47995] = Fluid3D([2797,2805,3095,2817],0); -ELEMENTS[47996] = Fluid3D([2913,3181,3118,3381],0); -ELEMENTS[47997] = Fluid3D([2797,2527,2805,2817],0); -ELEMENTS[47998] = Fluid3D([2797,2794,2527,2817],0); -ELEMENTS[47999] = Fluid3D([2797,2794,2817,3118],0); -ELEMENTS[48000] = Fluid3D([3095,2840,3118,3381],0); -ELEMENTS[48001] = Fluid3D([10057,10847,10325,11007],0); -ELEMENTS[48002] = Fluid3D([10325,10057,11007,10818],0); -ELEMENTS[48003] = Fluid3D([15317,14600,15141,14915],0); -ELEMENTS[48004] = Fluid3D([8994,8042,8413,8622],0); -ELEMENTS[48005] = Fluid3D([13475,13412,12473,12448],0); -ELEMENTS[48006] = Fluid3D([11795,11650,12293,11333],0); -ELEMENTS[48007] = Fluid3D([11795,11650,11333,10664],0); -ELEMENTS[48008] = Fluid3D([12293,11795,11333,12005],0); -ELEMENTS[48009] = Fluid3D([11333,11795,10664,10339],0); -ELEMENTS[48010] = Fluid3D([14077,14156,14820,14368],0); -ELEMENTS[48011] = Fluid3D([14274,14707,13597,14234],0); -ELEMENTS[48012] = Fluid3D([11456,11608,11186,10243],0); -ELEMENTS[48013] = Fluid3D([7732,7359,6842,6902],0); -ELEMENTS[48014] = Fluid3D([10298,11116,10254,11103],0); -ELEMENTS[48015] = Fluid3D([16222,16304,16594,16529],0); -ELEMENTS[48016] = Fluid3D([12422,12807,13492,12601],0); -ELEMENTS[48017] = Fluid3D([8507,9439,8614,9383],0); -ELEMENTS[48018] = Fluid3D([7284,6747,7634,6946],0); -ELEMENTS[48019] = Fluid3D([16422,15838,16029,16339],0); -ELEMENTS[48020] = Fluid3D([11181,11363,11739,12327],0); -ELEMENTS[48021] = Fluid3D([8395,8880,9389,9348],0); -ELEMENTS[48022] = Fluid3D([8395,8880,9348,7934],0); -ELEMENTS[48023] = Fluid3D([5835,5813,5213,5788],0); -ELEMENTS[48024] = Fluid3D([8775,8410,8366,7558],0); -ELEMENTS[48025] = Fluid3D([6978,7310,7119,8065],0); -ELEMENTS[48026] = Fluid3D([7810,7954,7951,8591],0); -ELEMENTS[48027] = Fluid3D([11073,11409,11064,10131],0); -ELEMENTS[48028] = Fluid3D([9376,10326,9414,10015],0); -ELEMENTS[48029] = Fluid3D([11099,11388,12113,11345],0); -ELEMENTS[48030] = Fluid3D([13417,12566,13242,12912],0); -ELEMENTS[48031] = Fluid3D([13417,12566,12912,13099],0); -ELEMENTS[48032] = Fluid3D([13596,13553,13527,14208],0); -ELEMENTS[48033] = Fluid3D([10202,9756,10778,10232],0); -ELEMENTS[48034] = Fluid3D([14430,15124,14294,14554],0); -ELEMENTS[48035] = Fluid3D([14294,14430,14554,14184],0); -ELEMENTS[48036] = Fluid3D([14430,15124,14554,14487],0); -ELEMENTS[48037] = Fluid3D([14554,14430,14487,14184],0); -ELEMENTS[48038] = Fluid3D([14487,14554,14184,14967],0); -ELEMENTS[48039] = Fluid3D([14487,14554,14967,15124],0); -ELEMENTS[48040] = Fluid3D([14554,14967,15124,14294],0); -ELEMENTS[48041] = Fluid3D([14554,14294,14184,14192],0); -ELEMENTS[48042] = Fluid3D([14554,14184,14967,14192],0); -ELEMENTS[48043] = Fluid3D([14554,14967,14294,14192],0); -ELEMENTS[48044] = Fluid3D([5286,4888,5320,5946],0); -ELEMENTS[48045] = Fluid3D([17568,17257,17097,17381],0); -ELEMENTS[48046] = Fluid3D([13534,12869,13990,13282],0); -ELEMENTS[48047] = Fluid3D([3196,3305,3271,3602],0); -ELEMENTS[48048] = Fluid3D([3196,3305,3602,3779],0); -ELEMENTS[48049] = Fluid3D([3602,3196,3779,3576],0); -ELEMENTS[48050] = Fluid3D([3779,3602,3576,3809],0); -ELEMENTS[48051] = Fluid3D([3779,3602,3809,3882],0); -ELEMENTS[48052] = Fluid3D([3602,3576,3809,3271],0); -ELEMENTS[48053] = Fluid3D([3779,3602,3882,3305],0); -ELEMENTS[48054] = Fluid3D([3602,3196,3576,3271],0); -ELEMENTS[48055] = Fluid3D([3602,3809,3882,3636],0); -ELEMENTS[48056] = Fluid3D([3602,3809,3636,3271],0); -ELEMENTS[48057] = Fluid3D([3809,3636,3271,3601],0); -ELEMENTS[48058] = Fluid3D([3809,3636,3601,3983],0); -ELEMENTS[48059] = Fluid3D([3809,3636,3983,4033],0); -ELEMENTS[48060] = Fluid3D([3305,3271,3602,3636],0); -ELEMENTS[48061] = Fluid3D([3602,3305,3636,3882],0); -ELEMENTS[48062] = Fluid3D([12565,13106,12774,13290],0); -ELEMENTS[48063] = Fluid3D([12565,13106,13290,13620],0); -ELEMENTS[48064] = Fluid3D([4946,5577,5136,5081],0); -ELEMENTS[48065] = Fluid3D([17060,17148,16945,17373],0); -ELEMENTS[48066] = Fluid3D([15452,15441,14859,15705],0); -ELEMENTS[48067] = Fluid3D([15452,15441,15705,16006],0); -ELEMENTS[48068] = Fluid3D([14859,15452,15705,15428],0); -ELEMENTS[48069] = Fluid3D([15705,15452,16006,16113],0); -ELEMENTS[48070] = Fluid3D([15705,15452,16113,15428],0); -ELEMENTS[48071] = Fluid3D([9542,10193,10099,9313],0); -ELEMENTS[48072] = Fluid3D([18671,18679,18648,18692],0); -ELEMENTS[48073] = Fluid3D([11411,10555,10811,9853],0); -ELEMENTS[48074] = Fluid3D([5888,6412,6196,5684],0); -ELEMENTS[48075] = Fluid3D([4726,4320,4290,4156],0); -ELEMENTS[48076] = Fluid3D([4320,4290,4156,3852],0); -ELEMENTS[48077] = Fluid3D([4156,4320,3852,4041],0); -ELEMENTS[48078] = Fluid3D([4156,4320,4041,4726],0); -ELEMENTS[48079] = Fluid3D([3852,4156,4041,3773],0); -ELEMENTS[48080] = Fluid3D([4156,4041,3773,4216],0); -ELEMENTS[48081] = Fluid3D([4156,4041,4216,4522],0); -ELEMENTS[48082] = Fluid3D([4320,4290,3852,4081],0); -ELEMENTS[48083] = Fluid3D([4290,3852,4081,3933],0); -ELEMENTS[48084] = Fluid3D([4320,4290,4081,4509],0); -ELEMENTS[48085] = Fluid3D([3852,4320,4081,3888],0); -ELEMENTS[48086] = Fluid3D([3773,4156,4216,4294],0); -ELEMENTS[48087] = Fluid3D([4320,3852,4041,3888],0); -ELEMENTS[48088] = Fluid3D([4290,4156,3852,3837],0); -ELEMENTS[48089] = Fluid3D([4041,4320,3888,4354],0); -ELEMENTS[48090] = Fluid3D([5679,5793,5670,5194],0); -ELEMENTS[48091] = Fluid3D([5793,5670,5194,5084],0); -ELEMENTS[48092] = Fluid3D([4048,3973,4285,3831],0); -ELEMENTS[48093] = Fluid3D([15010,15056,15670,15054],0); -ELEMENTS[48094] = Fluid3D([13212,13624,13642,14072],0); -ELEMENTS[48095] = Fluid3D([11102,10180,11201,11436],0); -ELEMENTS[48096] = Fluid3D([13995,13737,14293,14863],0); -ELEMENTS[48097] = Fluid3D([10261,10962,11350,10655],0); -ELEMENTS[48098] = Fluid3D([4596,4107,4639,4620],0); -ELEMENTS[48099] = Fluid3D([13745,13206,14174,12920],0); -ELEMENTS[48100] = Fluid3D([13745,13206,12920,12847],0); -ELEMENTS[48101] = Fluid3D([13206,12920,12847,12175],0); -ELEMENTS[48102] = Fluid3D([13206,12920,12175,12577],0); -ELEMENTS[48103] = Fluid3D([13206,12920,12577,13587],0); -ELEMENTS[48104] = Fluid3D([13206,12920,13587,14174],0); -ELEMENTS[48105] = Fluid3D([5910,5958,5576,5545],0); -ELEMENTS[48106] = Fluid3D([11480,12146,11028,11058],0); -ELEMENTS[48107] = Fluid3D([4379,4900,4752,4255],0); -ELEMENTS[48108] = Fluid3D([6168,5934,6412,6554],0); -ELEMENTS[48109] = Fluid3D([5934,6412,6554,5888],0); -ELEMENTS[48110] = Fluid3D([5934,6412,5888,5684],0); -ELEMENTS[48111] = Fluid3D([5888,5934,5684,5525],0); -ELEMENTS[48112] = Fluid3D([5888,5934,5525,5261],0); -ELEMENTS[48113] = Fluid3D([5888,5934,5261,5605],0); -ELEMENTS[48114] = Fluid3D([5888,5934,5605,6064],0); -ELEMENTS[48115] = Fluid3D([5888,5934,6064,6554],0); -ELEMENTS[48116] = Fluid3D([5934,6064,6554,6168],0); -ELEMENTS[48117] = Fluid3D([5934,5605,6064,6168],0); -ELEMENTS[48118] = Fluid3D([5525,5888,5261,5684],0); -ELEMENTS[48119] = Fluid3D([6064,6554,6168,6413],0); -ELEMENTS[48120] = Fluid3D([6064,6554,6413,7142],0); -ELEMENTS[48121] = Fluid3D([6168,6064,6413,5605],0); -ELEMENTS[48122] = Fluid3D([6554,6413,7142,6938],0); -ELEMENTS[48123] = Fluid3D([6554,6168,6413,6938],0); -ELEMENTS[48124] = Fluid3D([6554,6168,6938,6412],0); -ELEMENTS[48125] = Fluid3D([7142,6554,6938,7760],0); -ELEMENTS[48126] = Fluid3D([7142,6554,7760,7657],0); -ELEMENTS[48127] = Fluid3D([7760,7142,7657,8360],0); -ELEMENTS[48128] = Fluid3D([6168,6413,6938,7026],0); -ELEMENTS[48129] = Fluid3D([6413,6064,7142,6072],0); -ELEMENTS[48130] = Fluid3D([6413,6064,6072,5775],0); -ELEMENTS[48131] = Fluid3D([6064,6072,5775,5605],0); -ELEMENTS[48132] = Fluid3D([5605,5888,6064,6072],0); -ELEMENTS[48133] = Fluid3D([5888,6064,6072,6554],0); -ELEMENTS[48134] = Fluid3D([6064,6072,6554,7142],0); -ELEMENTS[48135] = Fluid3D([11906,12560,12403,12619],0); -ELEMENTS[48136] = Fluid3D([11012,11048,11986,11119],0); -ELEMENTS[48137] = Fluid3D([6231,5957,6134,5458],0); -ELEMENTS[48138] = Fluid3D([18224,18130,18264,17909],0); -ELEMENTS[48139] = Fluid3D([12587,12544,13515,12855],0); -ELEMENTS[48140] = Fluid3D([4500,4196,4241,4583],0); -ELEMENTS[48141] = Fluid3D([9990,10546,10425,9440],0); -ELEMENTS[48142] = Fluid3D([15204,15507,15316,14462],0); -ELEMENTS[48143] = Fluid3D([10631,10981,9747,10882],0); -ELEMENTS[48144] = Fluid3D([12174,12689,11565,12538],0); -ELEMENTS[48145] = Fluid3D([17969,18039,17845,18077],0); -ELEMENTS[48146] = Fluid3D([17845,17969,18077,18167],0); -ELEMENTS[48147] = Fluid3D([17969,18039,18077,18300],0); -ELEMENTS[48148] = Fluid3D([12102,12720,12016,12057],0); -ELEMENTS[48149] = Fluid3D([12102,12720,12057,11423],0); -ELEMENTS[48150] = Fluid3D([16530,16335,16396,16891],0); -ELEMENTS[48151] = Fluid3D([8007,7143,8002,7488],0); -ELEMENTS[48152] = Fluid3D([7143,8002,7488,7351],0); -ELEMENTS[48153] = Fluid3D([5429,4887,5560,5032],0); -ELEMENTS[48154] = Fluid3D([3511,3509,3421,3156],0); -ELEMENTS[48155] = Fluid3D([14484,13906,13836,15104],0); -ELEMENTS[48156] = Fluid3D([15113,15044,15009,14702],0); -ELEMENTS[48157] = Fluid3D([7557,7581,6835,7155],0); -ELEMENTS[48158] = Fluid3D([16960,16581,17002,17177],0); -ELEMENTS[48159] = Fluid3D([3649,3795,4015,3306],0); -ELEMENTS[48160] = Fluid3D([10559,10117,10407,11447],0); -ELEMENTS[48161] = Fluid3D([4476,4383,3952,4327],0); -ELEMENTS[48162] = Fluid3D([7658,7319,6951,7883],0); -ELEMENTS[48163] = Fluid3D([7658,7319,7883,8492],0); -ELEMENTS[48164] = Fluid3D([12918,13281,13036,12639],0); -ELEMENTS[48165] = Fluid3D([6614,6875,6755,7785],0); -ELEMENTS[48166] = Fluid3D([17426,17767,17660,17450],0); -ELEMENTS[48167] = Fluid3D([15363,15860,15107,15352],0); -ELEMENTS[48168] = Fluid3D([8589,8850,9481,8750],0); -ELEMENTS[48169] = Fluid3D([10108,9904,11170,10889],0); -ELEMENTS[48170] = Fluid3D([4509,4081,4658,4290],0); -ELEMENTS[48171] = Fluid3D([4081,4658,4290,4118],0); -ELEMENTS[48172] = Fluid3D([2406,2179,2234,2381],0); -ELEMENTS[48173] = Fluid3D([12491,13287,12803,12234],0); -ELEMENTS[48174] = Fluid3D([8471,8841,9506,8584],0); -ELEMENTS[48175] = Fluid3D([4829,5016,5458,5240],0); -ELEMENTS[48176] = Fluid3D([4829,5016,5240,5079],0); -ELEMENTS[48177] = Fluid3D([5458,4829,5240,5335],0); -ELEMENTS[48178] = Fluid3D([5240,4829,5079,5335],0); -ELEMENTS[48179] = Fluid3D([5079,5240,5335,5957],0); -ELEMENTS[48180] = Fluid3D([5063,5559,4996,5089],0); -ELEMENTS[48181] = Fluid3D([9935,10026,11057,10372],0); -ELEMENTS[48182] = Fluid3D([12210,12789,12872,12788],0); -ELEMENTS[48183] = Fluid3D([12789,12872,12788,13549],0); -ELEMENTS[48184] = Fluid3D([12789,12872,13549,12946],0); -ELEMENTS[48185] = Fluid3D([7352,6836,7237,7787],0); -ELEMENTS[48186] = Fluid3D([7237,7352,7787,8117],0); -ELEMENTS[48187] = Fluid3D([7352,7787,8117,7722],0); -ELEMENTS[48188] = Fluid3D([7787,8117,7722,8551],0); -ELEMENTS[48189] = Fluid3D([7787,8117,8551,7237],0); -ELEMENTS[48190] = Fluid3D([3327,3431,3074,3730],0); -ELEMENTS[48191] = Fluid3D([14942,14752,15462,15120],0); -ELEMENTS[48192] = Fluid3D([15462,14942,15120,15778],0); -ELEMENTS[48193] = Fluid3D([7903,8735,8305,7567],0); -ELEMENTS[48194] = Fluid3D([8792,8844,9387,9787],0); -ELEMENTS[48195] = Fluid3D([9387,8792,9787,10184],0); -ELEMENTS[48196] = Fluid3D([16661,16147,16591,16822],0); -ELEMENTS[48197] = Fluid3D([12766,13273,12908,12769],0); -ELEMENTS[48198] = Fluid3D([13273,12908,12769,13211],0); -ELEMENTS[48199] = Fluid3D([12908,12769,13211,11946],0); -ELEMENTS[48200] = Fluid3D([18357,18495,18305,18444],0); -ELEMENTS[48201] = Fluid3D([15251,15210,15181,14509],0); -ELEMENTS[48202] = Fluid3D([7754,7446,8257,8294],0); -ELEMENTS[48203] = Fluid3D([15148,14955,14415,15123],0); -ELEMENTS[48204] = Fluid3D([17159,17422,17133,17211],0); -ELEMENTS[48205] = Fluid3D([17159,17422,17211,17502],0); -ELEMENTS[48206] = Fluid3D([17159,17422,17502,17695],0); -ELEMENTS[48207] = Fluid3D([11283,12012,11632,10770],0); -ELEMENTS[48208] = Fluid3D([4593,4504,4022,4254],0); -ELEMENTS[48209] = Fluid3D([4593,4504,4254,4762],0); -ELEMENTS[48210] = Fluid3D([4022,4593,4254,4133],0); -ELEMENTS[48211] = Fluid3D([4593,4254,4133,4555],0); -ELEMENTS[48212] = Fluid3D([4593,4254,4555,4762],0); -ELEMENTS[48213] = Fluid3D([4254,4133,4555,4027],0); -ELEMENTS[48214] = Fluid3D([4133,4593,4555,4854],0); -ELEMENTS[48215] = Fluid3D([4254,4022,4133,3796],0); -ELEMENTS[48216] = Fluid3D([4133,4254,3796,4027],0); -ELEMENTS[48217] = Fluid3D([4022,4133,3796,3589],0); -ELEMENTS[48218] = Fluid3D([5822,5443,5864,5124],0); -ELEMENTS[48219] = Fluid3D([17674,17640,17322,17429],0); -ELEMENTS[48220] = Fluid3D([12061,11950,11297,12056],0); -ELEMENTS[48221] = Fluid3D([10200,10764,10110,10369],0); -ELEMENTS[48222] = Fluid3D([10764,10110,10369,11442],0); -ELEMENTS[48223] = Fluid3D([10369,10764,11442,11620],0); -ELEMENTS[48224] = Fluid3D([13000,12118,12332,12450],0); -ELEMENTS[48225] = Fluid3D([5192,5632,4958,5634],0); -ELEMENTS[48226] = Fluid3D([5192,5632,5634,5979],0); -ELEMENTS[48227] = Fluid3D([16605,16330,16251,15767],0); -ELEMENTS[48228] = Fluid3D([16157,16669,15999,16580],0); -ELEMENTS[48229] = Fluid3D([9352,9667,10351,9566],0); -ELEMENTS[48230] = Fluid3D([9667,10351,9566,9150],0); -ELEMENTS[48231] = Fluid3D([8222,8672,9169,7826],0); -ELEMENTS[48232] = Fluid3D([4451,4870,4610,4221],0); -ELEMENTS[48233] = Fluid3D([4451,4870,4221,4752],0); -ELEMENTS[48234] = Fluid3D([14896,14907,15435,15573],0); -ELEMENTS[48235] = Fluid3D([17121,17300,17440,17145],0); -ELEMENTS[48236] = Fluid3D([13990,13509,13919,12869],0); -ELEMENTS[48237] = Fluid3D([18371,18212,18102,18351],0); -ELEMENTS[48238] = Fluid3D([13370,13414,13873,13998],0); -ELEMENTS[48239] = Fluid3D([4514,4218,4029,4306],0); -ELEMENTS[48240] = Fluid3D([13781,13549,14057,12788],0); -ELEMENTS[48241] = Fluid3D([14252,14932,13907,14490],0); -ELEMENTS[48242] = Fluid3D([14252,14932,14490,15337],0); -ELEMENTS[48243] = Fluid3D([7663,7422,8057,8484],0); -ELEMENTS[48244] = Fluid3D([8057,7663,8484,8433],0); -ELEMENTS[48245] = Fluid3D([8057,7663,8433,7895],0); -ELEMENTS[48246] = Fluid3D([8484,8057,8433,9080],0); -ELEMENTS[48247] = Fluid3D([8057,8433,9080,7895],0); -ELEMENTS[48248] = Fluid3D([8433,8484,9080,9188],0); -ELEMENTS[48249] = Fluid3D([8433,9080,7895,8723],0); -ELEMENTS[48250] = Fluid3D([8433,9080,8723,9188],0); -ELEMENTS[48251] = Fluid3D([7663,8484,8433,8293],0); -ELEMENTS[48252] = Fluid3D([3392,3267,3273,3026],0); -ELEMENTS[48253] = Fluid3D([4884,4406,4411,4365],0); -ELEMENTS[48254] = Fluid3D([16956,17416,17105,17339],0); -ELEMENTS[48255] = Fluid3D([16956,17416,17339,17399],0); -ELEMENTS[48256] = Fluid3D([9735,10514,9614,9802],0); -ELEMENTS[48257] = Fluid3D([17842,17544,17569,17447],0); -ELEMENTS[48258] = Fluid3D([17544,17569,17447,17225],0); -ELEMENTS[48259] = Fluid3D([9698,8969,8829,9402],0); -ELEMENTS[48260] = Fluid3D([9698,8969,9402,9955],0); -ELEMENTS[48261] = Fluid3D([14083,14483,14643,13365],0); -ELEMENTS[48262] = Fluid3D([8612,8097,8347,7979],0); -ELEMENTS[48263] = Fluid3D([8612,8097,7979,8333],0); -ELEMENTS[48264] = Fluid3D([2379,2249,2322,2114],0); -ELEMENTS[48265] = Fluid3D([2379,2249,2114,2062],0); -ELEMENTS[48266] = Fluid3D([13471,12671,12690,12405],0); -ELEMENTS[48267] = Fluid3D([6960,7147,6251,7087],0); -ELEMENTS[48268] = Fluid3D([6960,7147,7087,7967],0); -ELEMENTS[48269] = Fluid3D([11025,10969,10812,11829],0); -ELEMENTS[48270] = Fluid3D([11025,10969,11829,11680],0); -ELEMENTS[48271] = Fluid3D([10812,11025,11829,10983],0); -ELEMENTS[48272] = Fluid3D([7916,7115,7910,6934],0); -ELEMENTS[48273] = Fluid3D([11363,10248,10074,10516],0); -ELEMENTS[48274] = Fluid3D([10248,10074,10516,9437],0); -ELEMENTS[48275] = Fluid3D([9001,8314,9231,8822],0); -ELEMENTS[48276] = Fluid3D([13187,12799,13058,13907],0); -ELEMENTS[48277] = Fluid3D([13422,13245,13311,12501],0); -ELEMENTS[48278] = Fluid3D([1712,1621,1698,1791],0); -ELEMENTS[48279] = Fluid3D([16141,16200,15921,15731],0); -ELEMENTS[48280] = Fluid3D([4437,4443,4440,4009],0); -ELEMENTS[48281] = Fluid3D([4443,4440,4009,4368],0); -ELEMENTS[48282] = Fluid3D([10327,10373,10930,11330],0); -ELEMENTS[48283] = Fluid3D([10930,10327,11330,10956],0); -ELEMENTS[48284] = Fluid3D([13817,14550,14562,14022],0); -ELEMENTS[48285] = Fluid3D([14550,14562,14022,15255],0); -ELEMENTS[48286] = Fluid3D([14562,13817,14022,13587],0); -ELEMENTS[48287] = Fluid3D([8814,9150,8336,9075],0); -ELEMENTS[48288] = Fluid3D([9150,8336,9075,9566],0); -ELEMENTS[48289] = Fluid3D([9075,9150,9566,9940],0); -ELEMENTS[48290] = Fluid3D([13211,13573,13882,13269],0); -ELEMENTS[48291] = Fluid3D([13211,13573,13269,12255],0); -ELEMENTS[48292] = Fluid3D([3510,3284,3035,3189],0); -ELEMENTS[48293] = Fluid3D([13160,13785,12730,13334],0); -ELEMENTS[48294] = Fluid3D([12557,13481,12757,13531],0); -ELEMENTS[48295] = Fluid3D([16573,16514,16619,17154],0); -ELEMENTS[48296] = Fluid3D([12189,11461,11758,11128],0); -ELEMENTS[48297] = Fluid3D([4489,4026,4015,4131],0); -ELEMENTS[48298] = Fluid3D([16832,17143,16554,16944],0); -ELEMENTS[48299] = Fluid3D([10696,10295,11322,10550],0); -ELEMENTS[48300] = Fluid3D([3916,4323,4466,4202],0); -ELEMENTS[48301] = Fluid3D([16901,16910,16769,16164],0); -ELEMENTS[48302] = Fluid3D([17653,17539,17586,17212],0); -ELEMENTS[48303] = Fluid3D([15834,15163,15424,15291],0); -ELEMENTS[48304] = Fluid3D([15424,15834,15291,15783],0); -ELEMENTS[48305] = Fluid3D([15424,15834,15783,15877],0); -ELEMENTS[48306] = Fluid3D([15558,15828,16164,15674],0); -ELEMENTS[48307] = Fluid3D([15475,15058,15038,15894],0); -ELEMENTS[48308] = Fluid3D([18158,18205,17938,18153],0); -ELEMENTS[48309] = Fluid3D([9433,10378,9408,9330],0); -ELEMENTS[48310] = Fluid3D([10615,9933,9620,10755],0); -ELEMENTS[48311] = Fluid3D([12785,12330,13518,13123],0); -ELEMENTS[48312] = Fluid3D([12785,12330,13123,12222],0); -ELEMENTS[48313] = Fluid3D([13123,12785,12222,12585],0); -ELEMENTS[48314] = Fluid3D([13123,12785,12585,13320],0); -ELEMENTS[48315] = Fluid3D([12222,13123,12585,12389],0); -ELEMENTS[48316] = Fluid3D([13518,12785,13123,13863],0); -ELEMENTS[48317] = Fluid3D([12785,12330,12222,11755],0); -ELEMENTS[48318] = Fluid3D([13199,12978,13702,12629],0); -ELEMENTS[48319] = Fluid3D([10107,9474,10503,10498],0); -ELEMENTS[48320] = Fluid3D([9630,9424,10369,10160],0); -ELEMENTS[48321] = Fluid3D([9069,9866,9973,10421],0); -ELEMENTS[48322] = Fluid3D([8754,8246,8299,7402],0); -ELEMENTS[48323] = Fluid3D([14842,15138,15563,15144],0); -ELEMENTS[48324] = Fluid3D([6606,6273,7212,6258],0); -ELEMENTS[48325] = Fluid3D([18138,18135,18286,18147],0); -ELEMENTS[48326] = Fluid3D([17431,17534,17884,17441],0); -ELEMENTS[48327] = Fluid3D([12759,11802,12304,11864],0); -ELEMENTS[48328] = Fluid3D([11725,12517,12658,12123],0); -ELEMENTS[48329] = Fluid3D([12658,11725,12123,11395],0); -ELEMENTS[48330] = Fluid3D([11725,12123,11395,10865],0); -ELEMENTS[48331] = Fluid3D([11395,11725,10865,10800],0); -ELEMENTS[48332] = Fluid3D([16180,15717,15506,15776],0); -ELEMENTS[48333] = Fluid3D([15717,15506,15776,15026],0); -ELEMENTS[48334] = Fluid3D([16180,15717,15776,16413],0); -ELEMENTS[48335] = Fluid3D([3584,3635,3274,3235],0); -ELEMENTS[48336] = Fluid3D([17929,17705,17596,17648],0); -ELEMENTS[48337] = Fluid3D([14289,14138,14023,14961],0); -ELEMENTS[48338] = Fluid3D([14289,14138,14961,14904],0); -ELEMENTS[48339] = Fluid3D([12734,13477,13915,13263],0); -ELEMENTS[48340] = Fluid3D([10549,10707,10815,11506],0); -ELEMENTS[48341] = Fluid3D([8598,9294,9062,8910],0); -ELEMENTS[48342] = Fluid3D([10872,11347,10359,11208],0); -ELEMENTS[48343] = Fluid3D([13307,12792,12610,13428],0); -ELEMENTS[48344] = Fluid3D([6626,7425,6709,6494],0); -ELEMENTS[48345] = Fluid3D([17779,17750,18039,17845],0); -ELEMENTS[48346] = Fluid3D([8259,8575,7539,7841],0); -ELEMENTS[48347] = Fluid3D([17647,17527,17708,17846],0); -ELEMENTS[48348] = Fluid3D([17961,17678,17505,17598],0); -ELEMENTS[48349] = Fluid3D([17678,17505,17598,17173],0); -ELEMENTS[48350] = Fluid3D([17598,17678,17173,17691],0); -ELEMENTS[48351] = Fluid3D([17598,17678,17691,17971],0); -ELEMENTS[48352] = Fluid3D([17598,17678,17971,17961],0); -ELEMENTS[48353] = Fluid3D([5800,5663,5611,4999],0); -ELEMENTS[48354] = Fluid3D([5512,5549,5193,5807],0); -ELEMENTS[48355] = Fluid3D([3516,3504,3770,3895],0); -ELEMENTS[48356] = Fluid3D([17444,17691,17297,17004],0); -ELEMENTS[48357] = Fluid3D([13161,13368,13691,12612],0); -ELEMENTS[48358] = Fluid3D([6080,5781,6161,6333],0); -ELEMENTS[48359] = Fluid3D([6080,5781,6333,5661],0); -ELEMENTS[48360] = Fluid3D([5781,6333,5661,6297],0); -ELEMENTS[48361] = Fluid3D([11311,12040,11048,11755],0); -ELEMENTS[48362] = Fluid3D([18411,18549,18450,18561],0); -ELEMENTS[48363] = Fluid3D([18549,18450,18561,18586],0); -ELEMENTS[48364] = Fluid3D([18561,18549,18586,18638],0); -ELEMENTS[48365] = Fluid3D([18411,18549,18561,18567],0); -ELEMENTS[48366] = Fluid3D([18549,18561,18567,18638],0); -ELEMENTS[48367] = Fluid3D([18567,18549,18638,18615],0); -ELEMENTS[48368] = Fluid3D([18567,18549,18615,18510],0); -ELEMENTS[48369] = Fluid3D([18411,18549,18567,18510],0); -ELEMENTS[48370] = Fluid3D([16544,16636,16263,16968],0); -ELEMENTS[48371] = Fluid3D([12236,11318,11890,11708],0); -ELEMENTS[48372] = Fluid3D([14448,14424,13884,14654],0); -ELEMENTS[48373] = Fluid3D([15559,15808,15305,15906],0); -ELEMENTS[48374] = Fluid3D([8607,9117,9236,7908],0); -ELEMENTS[48375] = Fluid3D([11063,10805,10439,9612],0); -ELEMENTS[48376] = Fluid3D([7300,7303,7937,7077],0); -ELEMENTS[48377] = Fluid3D([7300,7303,7077,6592],0); -ELEMENTS[48378] = Fluid3D([7303,7077,6592,7417],0); -ELEMENTS[48379] = Fluid3D([6592,7303,7417,6928],0); -ELEMENTS[48380] = Fluid3D([7303,7077,7417,8208],0); -ELEMENTS[48381] = Fluid3D([3360,2979,3090,3292],0); -ELEMENTS[48382] = Fluid3D([16348,16139,15678,15667],0); -ELEMENTS[48383] = Fluid3D([15287,15804,15593,16129],0); -ELEMENTS[48384] = Fluid3D([15804,15593,16129,16261],0); -ELEMENTS[48385] = Fluid3D([16129,15804,16261,16298],0); -ELEMENTS[48386] = Fluid3D([11419,11160,12090,12544],0); -ELEMENTS[48387] = Fluid3D([4030,3956,3721,3598],0); -ELEMENTS[48388] = Fluid3D([13930,14218,14645,14258],0); -ELEMENTS[48389] = Fluid3D([9655,8844,9387,8247],0); -ELEMENTS[48390] = Fluid3D([8271,8014,7485,8310],0); -ELEMENTS[48391] = Fluid3D([8271,8014,8310,8908],0); -ELEMENTS[48392] = Fluid3D([8014,7485,8310,7852],0); -ELEMENTS[48393] = Fluid3D([8014,8310,8908,7852],0); -ELEMENTS[48394] = Fluid3D([7485,8271,8310,8044],0); -ELEMENTS[48395] = Fluid3D([3208,3304,3629,3680],0); -ELEMENTS[48396] = Fluid3D([3304,3629,3680,3546],0); -ELEMENTS[48397] = Fluid3D([3680,3304,3546,3334],0); -ELEMENTS[48398] = Fluid3D([8763,8514,9334,8530],0); -ELEMENTS[48399] = Fluid3D([15908,16246,16450,16434],0); -ELEMENTS[48400] = Fluid3D([3466,3909,3547,3797],0); -ELEMENTS[48401] = Fluid3D([18107,17995,18132,17999],0); -ELEMENTS[48402] = Fluid3D([12829,13352,13057,14021],0); -ELEMENTS[48403] = Fluid3D([5172,5578,5231,5715],0); -ELEMENTS[48404] = Fluid3D([5172,5578,5715,5740],0); -ELEMENTS[48405] = Fluid3D([16930,17259,17212,16803],0); -ELEMENTS[48406] = Fluid3D([16955,16600,16515,16194],0); -ELEMENTS[48407] = Fluid3D([8311,8178,8338,7591],0); -ELEMENTS[48408] = Fluid3D([8178,8338,7591,7808],0); -ELEMENTS[48409] = Fluid3D([3881,4208,3980,3838],0); -ELEMENTS[48410] = Fluid3D([4208,3980,3838,4309],0); -ELEMENTS[48411] = Fluid3D([17014,16900,17136,17469],0); -ELEMENTS[48412] = Fluid3D([11031,11935,11026,11189],0); -ELEMENTS[48413] = Fluid3D([3784,3605,3934,4241],0); -ELEMENTS[48414] = Fluid3D([3008,2911,3197,3492],0); -ELEMENTS[48415] = Fluid3D([3197,3008,3492,3337],0); -ELEMENTS[48416] = Fluid3D([3197,3008,3337,3189],0); -ELEMENTS[48417] = Fluid3D([3337,3197,3189,3638],0); -ELEMENTS[48418] = Fluid3D([3189,3337,3638,3284],0); -ELEMENTS[48419] = Fluid3D([3337,3638,3284,3683],0); -ELEMENTS[48420] = Fluid3D([3337,3638,3683,3985],0); -ELEMENTS[48421] = Fluid3D([3284,3337,3683,3492],0); -ELEMENTS[48422] = Fluid3D([3337,3683,3492,3985],0); -ELEMENTS[48423] = Fluid3D([3683,3492,3985,3990],0); -ELEMENTS[48424] = Fluid3D([3985,3683,3990,3879],0); -ELEMENTS[48425] = Fluid3D([3683,3990,3879,3553],0); -ELEMENTS[48426] = Fluid3D([3492,3197,3337,3583],0); -ELEMENTS[48427] = Fluid3D([3638,3683,3985,3879],0); -ELEMENTS[48428] = Fluid3D([3197,3337,3583,3638],0); -ELEMENTS[48429] = Fluid3D([3284,3337,3492,3008],0); -ELEMENTS[48430] = Fluid3D([3284,3337,3008,3189],0); -ELEMENTS[48431] = Fluid3D([4684,4701,4183,4610],0); -ELEMENTS[48432] = Fluid3D([18129,18326,18152,18410],0); -ELEMENTS[48433] = Fluid3D([12020,12817,12878,13489],0); -ELEMENTS[48434] = Fluid3D([4924,4812,4388,4229],0); -ELEMENTS[48435] = Fluid3D([16816,16418,16873,16251],0); -ELEMENTS[48436] = Fluid3D([8954,9438,9391,9782],0); -ELEMENTS[48437] = Fluid3D([10007,10868,10558,10263],0); -ELEMENTS[48438] = Fluid3D([12198,13117,12277,12478],0); -ELEMENTS[48439] = Fluid3D([8721,8218,8441,9417],0); -ELEMENTS[48440] = Fluid3D([16617,16804,16745,16416],0); -ELEMENTS[48441] = Fluid3D([8771,8530,8418,7581],0); -ELEMENTS[48442] = Fluid3D([17249,16921,17293,17031],0); -ELEMENTS[48443] = Fluid3D([15353,15478,15767,16251],0); -ELEMENTS[48444] = Fluid3D([12015,12054,12549,12831],0); -ELEMENTS[48445] = Fluid3D([15061,15566,14815,14594],0); -ELEMENTS[48446] = Fluid3D([14031,14143,14305,14976],0); -ELEMENTS[48447] = Fluid3D([4710,4822,5086,4357],0); -ELEMENTS[48448] = Fluid3D([16123,16528,16544,16968],0); -ELEMENTS[48449] = Fluid3D([5285,5064,5355,5784],0); -ELEMENTS[48450] = Fluid3D([12662,12753,13644,13199],0); -ELEMENTS[48451] = Fluid3D([12662,12753,13199,12629],0); -ELEMENTS[48452] = Fluid3D([12703,13259,13736,12754],0); -ELEMENTS[48453] = Fluid3D([9498,9909,10706,10318],0); -ELEMENTS[48454] = Fluid3D([15083,15312,14478,15081],0); -ELEMENTS[48455] = Fluid3D([6043,6562,6715,6348],0); -ELEMENTS[48456] = Fluid3D([15960,16241,15829,16350],0); -ELEMENTS[48457] = Fluid3D([2163,1967,1942,2099],0); -ELEMENTS[48458] = Fluid3D([2163,1967,2099,2123],0); -ELEMENTS[48459] = Fluid3D([8068,8999,8692,8858],0); -ELEMENTS[48460] = Fluid3D([14740,14627,15113,15529],0); -ELEMENTS[48461] = Fluid3D([13480,12902,13493,13616],0); -ELEMENTS[48462] = Fluid3D([7140,6819,7235,7895],0); -ELEMENTS[48463] = Fluid3D([9445,9614,9028,9724],0); -ELEMENTS[48464] = Fluid3D([9667,9150,9918,10351],0); -ELEMENTS[48465] = Fluid3D([5296,4906,5625,5531],0); -ELEMENTS[48466] = Fluid3D([5625,5296,5531,5863],0); -ELEMENTS[48467] = Fluid3D([5208,5320,4556,4646],0); -ELEMENTS[48468] = Fluid3D([5208,5320,4646,5194],0); -ELEMENTS[48469] = Fluid3D([16525,16787,17172,16810],0); -ELEMENTS[48470] = Fluid3D([11742,11984,11809,12827],0); -ELEMENTS[48471] = Fluid3D([9801,9630,10641,10800],0); -ELEMENTS[48472] = Fluid3D([13284,14047,14009,13253],0); -ELEMENTS[48473] = Fluid3D([8471,9140,8840,9377],0); -ELEMENTS[48474] = Fluid3D([2892,3229,2845,2916],0); -ELEMENTS[48475] = Fluid3D([2892,3229,2916,3120],0); -ELEMENTS[48476] = Fluid3D([2845,2892,2916,2607],0); -ELEMENTS[48477] = Fluid3D([4364,4153,4566,4832],0); -ELEMENTS[48478] = Fluid3D([16683,16658,16889,17113],0); -ELEMENTS[48479] = Fluid3D([3708,3867,3370,3561],0); -ELEMENTS[48480] = Fluid3D([16421,16179,16276,15636],0); -ELEMENTS[48481] = Fluid3D([9998,10548,11146,10651],0); -ELEMENTS[48482] = Fluid3D([11146,9998,10651,10185],0); -ELEMENTS[48483] = Fluid3D([10548,11146,10651,11365],0); -ELEMENTS[48484] = Fluid3D([11146,10651,11365,11537],0); -ELEMENTS[48485] = Fluid3D([10651,10548,11365,9917],0); -ELEMENTS[48486] = Fluid3D([9998,10548,10651,9285],0); -ELEMENTS[48487] = Fluid3D([4526,4338,3958,4087],0); -ELEMENTS[48488] = Fluid3D([3844,4356,4169,3984],0); -ELEMENTS[48489] = Fluid3D([16894,16798,16574,16280],0); -ELEMENTS[48490] = Fluid3D([16665,16455,16762,16033],0); -ELEMENTS[48491] = Fluid3D([13017,12916,12636,13706],0); -ELEMENTS[48492] = Fluid3D([10912,10050,10130,11028],0); -ELEMENTS[48493] = Fluid3D([10130,10912,11028,11168],0); -ELEMENTS[48494] = Fluid3D([17649,17600,17372,17175],0); -ELEMENTS[48495] = Fluid3D([11013,11440,10768,11229],0); -ELEMENTS[48496] = Fluid3D([8035,7586,7451,7148],0); -ELEMENTS[48497] = Fluid3D([7586,7451,7148,6918],0); -ELEMENTS[48498] = Fluid3D([8035,7586,7148,7147],0); -ELEMENTS[48499] = Fluid3D([14296,13526,14072,14371],0); -ELEMENTS[48500] = Fluid3D([14296,13526,14371,13660],0); -ELEMENTS[48501] = Fluid3D([15650,15354,15056,15949],0); -ELEMENTS[48502] = Fluid3D([15999,16231,15871,15983],0); -ELEMENTS[48503] = Fluid3D([9098,9330,10043,9175],0); -ELEMENTS[48504] = Fluid3D([15223,14510,15219,14956],0); -ELEMENTS[48505] = Fluid3D([13760,13955,13668,14539],0); -ELEMENTS[48506] = Fluid3D([2060,2260,2171,2087],0); -ELEMENTS[48507] = Fluid3D([2060,2260,2087,2080],0); -ELEMENTS[48508] = Fluid3D([12568,12895,12856,13867],0); -ELEMENTS[48509] = Fluid3D([14510,14152,14956,14389],0); -ELEMENTS[48510] = Fluid3D([17567,17570,17213,17462],0); -ELEMENTS[48511] = Fluid3D([17298,17445,17286,17647],0); -ELEMENTS[48512] = Fluid3D([13197,12542,13148,13559],0); -ELEMENTS[48513] = Fluid3D([6341,6904,7319,6951],0); -ELEMENTS[48514] = Fluid3D([14922,14576,14660,15114],0); -ELEMENTS[48515] = Fluid3D([14922,14576,15114,15375],0); -ELEMENTS[48516] = Fluid3D([14922,14576,15375,14720],0); -ELEMENTS[48517] = Fluid3D([10110,10839,11442,10200],0); -ELEMENTS[48518] = Fluid3D([10110,10839,10200,10015],0); -ELEMENTS[48519] = Fluid3D([8517,7813,7893,8569],0); -ELEMENTS[48520] = Fluid3D([9225,8970,8784,9793],0); -ELEMENTS[48521] = Fluid3D([9044,8604,7991,7888],0); -ELEMENTS[48522] = Fluid3D([8604,7991,7888,7487],0); -ELEMENTS[48523] = Fluid3D([9044,8604,7888,8154],0); -ELEMENTS[48524] = Fluid3D([17433,17904,17731,17671],0); -ELEMENTS[48525] = Fluid3D([6512,6572,7036,7969],0); -ELEMENTS[48526] = Fluid3D([16446,16149,16574,16278],0); -ELEMENTS[48527] = Fluid3D([13396,13757,12808,12850],0); -ELEMENTS[48528] = Fluid3D([6614,6585,7015,7406],0); -ELEMENTS[48529] = Fluid3D([10859,10473,11204,11009],0); -ELEMENTS[48530] = Fluid3D([16961,17067,16652,17036],0); -ELEMENTS[48531] = Fluid3D([16624,16820,16868,16313],0); -ELEMENTS[48532] = Fluid3D([7967,7707,7928,6960],0); -ELEMENTS[48533] = Fluid3D([3772,4034,4003,3916],0); -ELEMENTS[48534] = Fluid3D([3772,4034,3916,3462],0); -ELEMENTS[48535] = Fluid3D([3988,4182,4125,4557],0); -ELEMENTS[48536] = Fluid3D([4182,4125,4557,4572],0); -ELEMENTS[48537] = Fluid3D([4557,4182,4572,4765],0); -ELEMENTS[48538] = Fluid3D([4125,3988,4557,4480],0); -ELEMENTS[48539] = Fluid3D([5374,5494,5517,4843],0); -ELEMENTS[48540] = Fluid3D([5374,5494,4843,4840],0); -ELEMENTS[48541] = Fluid3D([16134,16140,16690,16613],0); -ELEMENTS[48542] = Fluid3D([6644,5922,6639,6682],0); -ELEMENTS[48543] = Fluid3D([3924,3817,4196,3619],0); -ELEMENTS[48544] = Fluid3D([5886,5452,6055,5801],0); -ELEMENTS[48545] = Fluid3D([15569,16112,15914,16029],0); -ELEMENTS[48546] = Fluid3D([14715,15094,15182,15587],0); -ELEMENTS[48547] = Fluid3D([15182,14715,15587,14854],0); -ELEMENTS[48548] = Fluid3D([15182,14715,14854,14579],0); -ELEMENTS[48549] = Fluid3D([13739,14423,14481,13842],0); -ELEMENTS[48550] = Fluid3D([1976,2143,2037,2186],0); -ELEMENTS[48551] = Fluid3D([1976,2143,2186,2109],0); -ELEMENTS[48552] = Fluid3D([2994,2752,2800,3046],0); -ELEMENTS[48553] = Fluid3D([2994,2752,3046,3067],0); -ELEMENTS[48554] = Fluid3D([2752,3046,3067,2637],0); -ELEMENTS[48555] = Fluid3D([3046,2994,3067,3490],0); -ELEMENTS[48556] = Fluid3D([2800,2994,3046,3151],0); -ELEMENTS[48557] = Fluid3D([2994,3046,3151,3490],0); -ELEMENTS[48558] = Fluid3D([3046,2800,3151,3032],0); -ELEMENTS[48559] = Fluid3D([3151,3046,3032,3402],0); -ELEMENTS[48560] = Fluid3D([3046,3032,3402,3025],0); -ELEMENTS[48561] = Fluid3D([3046,2800,3032,2637],0); -ELEMENTS[48562] = Fluid3D([3032,3151,3402,3116],0); -ELEMENTS[48563] = Fluid3D([3151,3046,3402,3490],0); -ELEMENTS[48564] = Fluid3D([3032,3151,3116,2800],0); -ELEMENTS[48565] = Fluid3D([2800,2994,3151,2970],0); -ELEMENTS[48566] = Fluid3D([12609,12411,12851,11708],0); -ELEMENTS[48567] = Fluid3D([11856,12805,12664,12182],0); -ELEMENTS[48568] = Fluid3D([2620,2555,2823,2501],0); -ELEMENTS[48569] = Fluid3D([2823,2620,2501,2547],0); -ELEMENTS[48570] = Fluid3D([2620,2501,2547,2250],0); -ELEMENTS[48571] = Fluid3D([2620,2555,2501,2250],0); -ELEMENTS[48572] = Fluid3D([6255,6099,5624,6118],0); -ELEMENTS[48573] = Fluid3D([9712,10560,10221,10539],0); -ELEMENTS[48574] = Fluid3D([17546,17814,17623,17449],0); -ELEMENTS[48575] = Fluid3D([17546,17814,17449,17216],0); -ELEMENTS[48576] = Fluid3D([17449,17546,17216,17623],0); -ELEMENTS[48577] = Fluid3D([8851,8747,8022,7971],0); -ELEMENTS[48578] = Fluid3D([8747,8022,7971,7635],0); -ELEMENTS[48579] = Fluid3D([15137,15429,15849,15814],0); -ELEMENTS[48580] = Fluid3D([9445,10282,9724,9299],0); -ELEMENTS[48581] = Fluid3D([9445,10282,9299,9941],0); -ELEMENTS[48582] = Fluid3D([9445,10282,9941,9802],0); -ELEMENTS[48583] = Fluid3D([9941,9445,9802,9375],0); -ELEMENTS[48584] = Fluid3D([9802,9941,9375,10544],0); -ELEMENTS[48585] = Fluid3D([9299,9445,9941,9375],0); -ELEMENTS[48586] = Fluid3D([9802,9941,10544,10964],0); -ELEMENTS[48587] = Fluid3D([9941,9299,9375,10289],0); -ELEMENTS[48588] = Fluid3D([9375,9941,10289,10544],0); -ELEMENTS[48589] = Fluid3D([9802,9941,10964,10282],0); -ELEMENTS[48590] = Fluid3D([9941,10964,10282,10408],0); -ELEMENTS[48591] = Fluid3D([9941,9299,10289,10408],0); -ELEMENTS[48592] = Fluid3D([4491,4542,4212,4040],0); -ELEMENTS[48593] = Fluid3D([14612,14885,15303,14977],0); -ELEMENTS[48594] = Fluid3D([12721,12550,12234,11220],0); -ELEMENTS[48595] = Fluid3D([7852,8245,8764,8270],0); -ELEMENTS[48596] = Fluid3D([2930,3056,3000,2789],0); -ELEMENTS[48597] = Fluid3D([2930,3056,2789,2504],0); -ELEMENTS[48598] = Fluid3D([15680,15313,16053,15683],0); -ELEMENTS[48599] = Fluid3D([7790,7516,7243,8121],0); -ELEMENTS[48600] = Fluid3D([13291,13317,13886,13547],0); -ELEMENTS[48601] = Fluid3D([18482,18258,18372,18279],0); -ELEMENTS[48602] = Fluid3D([18334,18290,18439,18307],0); -ELEMENTS[48603] = Fluid3D([2433,2627,2368,2616],0); -ELEMENTS[48604] = Fluid3D([2627,2368,2616,2558],0); -ELEMENTS[48605] = Fluid3D([2433,2627,2616,2697],0); -ELEMENTS[48606] = Fluid3D([11046,11055,9914,10576],0); -ELEMENTS[48607] = Fluid3D([9073,9709,8591,9788],0); -ELEMENTS[48608] = Fluid3D([16089,16656,16305,16486],0); -ELEMENTS[48609] = Fluid3D([12351,13041,11917,12275],0); -ELEMENTS[48610] = Fluid3D([6986,6530,6890,6402],0); -ELEMENTS[48611] = Fluid3D([6986,6530,6402,6164],0); -ELEMENTS[48612] = Fluid3D([3469,3398,3036,3200],0); -ELEMENTS[48613] = Fluid3D([3036,3469,3200,3182],0); -ELEMENTS[48614] = Fluid3D([3469,3398,3200,3797],0); -ELEMENTS[48615] = Fluid3D([10865,10235,11257,10540],0); -ELEMENTS[48616] = Fluid3D([11553,11644,11660,12171],0); -ELEMENTS[48617] = Fluid3D([17951,17965,18090,18198],0); -ELEMENTS[48618] = Fluid3D([8049,7390,8098,8219],0); -ELEMENTS[48619] = Fluid3D([7390,8098,8219,7447],0); -ELEMENTS[48620] = Fluid3D([8098,8049,8219,8852],0); -ELEMENTS[48621] = Fluid3D([3918,3544,3660,4287],0); -ELEMENTS[48622] = Fluid3D([7152,6898,6301,6479],0); -ELEMENTS[48623] = Fluid3D([16147,16546,15918,16368],0); -ELEMENTS[48624] = Fluid3D([3885,3829,3982,3560],0); -ELEMENTS[48625] = Fluid3D([18350,18421,18378,18562],0); -ELEMENTS[48626] = Fluid3D([11018,11525,11702,10811],0); -ELEMENTS[48627] = Fluid3D([11702,11018,10811,10478],0); -ELEMENTS[48628] = Fluid3D([16041,15703,15823,15302],0); -ELEMENTS[48629] = Fluid3D([15703,15823,15302,15720],0); -ELEMENTS[48630] = Fluid3D([16041,15703,15302,15604],0); -ELEMENTS[48631] = Fluid3D([15302,15703,15720,15257],0); -ELEMENTS[48632] = Fluid3D([15703,15823,15720,16229],0); -ELEMENTS[48633] = Fluid3D([15302,15703,15257,15604],0); -ELEMENTS[48634] = Fluid3D([18566,18635,18631,18633],0); -ELEMENTS[48635] = Fluid3D([6911,7253,7244,6180],0); -ELEMENTS[48636] = Fluid3D([15470,15689,16078,16149],0); -ELEMENTS[48637] = Fluid3D([11571,11474,11542,10666],0); -ELEMENTS[48638] = Fluid3D([5897,5239,5713,5093],0); -ELEMENTS[48639] = Fluid3D([14812,15039,14625,15364],0); -ELEMENTS[48640] = Fluid3D([11020,10399,9781,9464],0); -ELEMENTS[48641] = Fluid3D([10399,9781,9464,9189],0); -ELEMENTS[48642] = Fluid3D([7619,7669,6830,7468],0); -ELEMENTS[48643] = Fluid3D([17399,17609,17706,17882],0); -ELEMENTS[48644] = Fluid3D([17609,17706,17882,18033],0); -ELEMENTS[48645] = Fluid3D([9028,9918,9724,9614],0); -ELEMENTS[48646] = Fluid3D([14511,14546,15043,14224],0); -ELEMENTS[48647] = Fluid3D([15043,14511,14224,14254],0); -ELEMENTS[48648] = Fluid3D([14511,14546,14224,13701],0); -ELEMENTS[48649] = Fluid3D([11683,11548,12450,11852],0); -ELEMENTS[48650] = Fluid3D([7359,6510,6711,6842],0); -ELEMENTS[48651] = Fluid3D([13782,12857,13710,13365],0); -ELEMENTS[48652] = Fluid3D([13782,12857,13365,13836],0); -ELEMENTS[48653] = Fluid3D([7813,7214,7853,8517],0); -ELEMENTS[48654] = Fluid3D([17417,17163,17031,17431],0); -ELEMENTS[48655] = Fluid3D([13109,13333,13652,12673],0); -ELEMENTS[48656] = Fluid3D([8023,8518,8161,9285],0); -ELEMENTS[48657] = Fluid3D([12405,11992,11278,11439],0); -ELEMENTS[48658] = Fluid3D([9455,9687,9146,8834],0); -ELEMENTS[48659] = Fluid3D([10498,10780,10470,11839],0); -ELEMENTS[48660] = Fluid3D([11147,12187,10978,11117],0); -ELEMENTS[48661] = Fluid3D([15035,15090,14506,14525],0); -ELEMENTS[48662] = Fluid3D([14506,15035,14525,15024],0); -ELEMENTS[48663] = Fluid3D([14506,15035,15024,15390],0); -ELEMENTS[48664] = Fluid3D([15035,14525,15024,14933],0); -ELEMENTS[48665] = Fluid3D([14525,15024,14933,14009],0); -ELEMENTS[48666] = Fluid3D([14525,14506,15024,14009],0); -ELEMENTS[48667] = Fluid3D([4801,4913,4858,5509],0); -ELEMENTS[48668] = Fluid3D([16757,17216,16871,16954],0); -ELEMENTS[48669] = Fluid3D([2056,1975,1928,1816],0); -ELEMENTS[48670] = Fluid3D([8845,8779,8090,9179],0); -ELEMENTS[48671] = Fluid3D([5179,5182,4700,4655],0); -ELEMENTS[48672] = Fluid3D([17913,17979,18103,18012],0); -ELEMENTS[48673] = Fluid3D([5173,5037,5385,5133],0); -ELEMENTS[48674] = Fluid3D([17223,17390,17112,16885],0); -ELEMENTS[48675] = Fluid3D([16086,15712,15617,15306],0); -ELEMENTS[48676] = Fluid3D([8102,8351,7432,7443],0); -ELEMENTS[48677] = Fluid3D([4367,4471,4928,4712],0); -ELEMENTS[48678] = Fluid3D([4367,4471,4712,4131],0); -ELEMENTS[48679] = Fluid3D([4712,4367,4131,4632],0); -ELEMENTS[48680] = Fluid3D([4367,4471,4131,4026],0); -ELEMENTS[48681] = Fluid3D([4367,4471,4026,4000],0); -ELEMENTS[48682] = Fluid3D([4928,4367,4712,4632],0); -ELEMENTS[48683] = Fluid3D([10143,10429,10372,11216],0); -ELEMENTS[48684] = Fluid3D([17269,17637,17719,17701],0); -ELEMENTS[48685] = Fluid3D([9169,8927,9822,8740],0); -ELEMENTS[48686] = Fluid3D([9169,8927,8740,7826],0); -ELEMENTS[48687] = Fluid3D([9822,9169,8740,9787],0); -ELEMENTS[48688] = Fluid3D([6558,6756,6886,7611],0); -ELEMENTS[48689] = Fluid3D([6565,6803,6813,5812],0); -ELEMENTS[48690] = Fluid3D([15025,14589,15207,15266],0); -ELEMENTS[48691] = Fluid3D([12478,12749,13364,12277],0); -ELEMENTS[48692] = Fluid3D([4621,4743,4264,4215],0); -ELEMENTS[48693] = Fluid3D([10030,9610,9127,9290],0); -ELEMENTS[48694] = Fluid3D([9610,9127,9290,8432],0); -ELEMENTS[48695] = Fluid3D([10030,9610,9290,10605],0); -ELEMENTS[48696] = Fluid3D([9290,9610,8432,9240],0); -ELEMENTS[48697] = Fluid3D([9290,9610,9240,10209],0); -ELEMENTS[48698] = Fluid3D([11083,11422,12228,11287],0); -ELEMENTS[48699] = Fluid3D([11083,11422,11287,10061],0); -ELEMENTS[48700] = Fluid3D([11287,11083,10061,10541],0); -ELEMENTS[48701] = Fluid3D([12228,11083,11287,11460],0); -ELEMENTS[48702] = Fluid3D([11083,11287,11460,10541],0); -ELEMENTS[48703] = Fluid3D([10404,11099,10829,10566],0); -ELEMENTS[48704] = Fluid3D([10420,10059,10123,9341],0); -ELEMENTS[48705] = Fluid3D([10420,10059,9341,9635],0); -ELEMENTS[48706] = Fluid3D([10420,10059,9635,10739],0); -ELEMENTS[48707] = Fluid3D([14261,14051,13732,14522],0); -ELEMENTS[48708] = Fluid3D([6571,7065,7320,6789],0); -ELEMENTS[48709] = Fluid3D([7940,7880,7794,8884],0); -ELEMENTS[48710] = Fluid3D([7960,8654,7984,8736],0); -ELEMENTS[48711] = Fluid3D([5786,5498,5186,5460],0); -ELEMENTS[48712] = Fluid3D([13291,13886,14257,13547],0); -ELEMENTS[48713] = Fluid3D([17631,17408,17786,17775],0); -ELEMENTS[48714] = Fluid3D([17786,17631,17775,17951],0); -ELEMENTS[48715] = Fluid3D([1985,1836,2019,1870],0); -ELEMENTS[48716] = Fluid3D([17955,17964,18202,18018],0); -ELEMENTS[48717] = Fluid3D([17955,17964,18018,17728],0); -ELEMENTS[48718] = Fluid3D([17964,18018,17728,17625],0); -ELEMENTS[48719] = Fluid3D([9231,10233,9602,9984],0); -ELEMENTS[48720] = Fluid3D([10232,11000,10830,10543],0); -ELEMENTS[48721] = Fluid3D([10830,10232,10543,9527],0); -ELEMENTS[48722] = Fluid3D([10232,11000,10543,11073],0); -ELEMENTS[48723] = Fluid3D([10543,10232,11073,9549],0); -ELEMENTS[48724] = Fluid3D([11744,12486,12783,12161],0); -ELEMENTS[48725] = Fluid3D([12387,11748,12359,13008],0); -ELEMENTS[48726] = Fluid3D([12359,12387,13008,12379],0); -ELEMENTS[48727] = Fluid3D([12387,13008,12379,13304],0); -ELEMENTS[48728] = Fluid3D([13397,13647,13221,14192],0); -ELEMENTS[48729] = Fluid3D([16543,15979,16536,16453],0); -ELEMENTS[48730] = Fluid3D([8188,7644,8103,8927],0); -ELEMENTS[48731] = Fluid3D([4523,4520,4777,4240],0); -ELEMENTS[48732] = Fluid3D([4777,4523,4240,4709],0); -ELEMENTS[48733] = Fluid3D([4240,4777,4709,5046],0); -ELEMENTS[48734] = Fluid3D([4777,4523,4709,5238],0); -ELEMENTS[48735] = Fluid3D([4523,4240,4709,4537],0); -ELEMENTS[48736] = Fluid3D([4777,4709,5046,5238],0); -ELEMENTS[48737] = Fluid3D([4240,4709,4537,4705],0); -ELEMENTS[48738] = Fluid3D([4709,4537,4705,5238],0); -ELEMENTS[48739] = Fluid3D([4705,4709,5238,5046],0); -ELEMENTS[48740] = Fluid3D([4705,4709,5046,4240],0); -ELEMENTS[48741] = Fluid3D([4709,4537,5238,4979],0); -ELEMENTS[48742] = Fluid3D([5238,4709,4979,4523],0); -ELEMENTS[48743] = Fluid3D([4709,4537,4979,4523],0); -ELEMENTS[48744] = Fluid3D([6481,6772,7135,5995],0); -ELEMENTS[48745] = Fluid3D([17100,16904,17359,17055],0); -ELEMENTS[48746] = Fluid3D([16591,16822,17160,16661],0); -ELEMENTS[48747] = Fluid3D([6863,6982,7390,7447],0); -ELEMENTS[48748] = Fluid3D([6863,6982,7447,6910],0); -ELEMENTS[48749] = Fluid3D([7447,6863,6910,8007],0); -ELEMENTS[48750] = Fluid3D([6982,7447,6910,7111],0); -ELEMENTS[48751] = Fluid3D([6982,7447,7111,7244],0); -ELEMENTS[48752] = Fluid3D([7447,6910,7111,7871],0); -ELEMENTS[48753] = Fluid3D([7111,7447,7871,7786],0); -ELEMENTS[48754] = Fluid3D([7871,7111,7786,7471],0); -ELEMENTS[48755] = Fluid3D([7111,7447,7786,7244],0); -ELEMENTS[48756] = Fluid3D([6982,7390,7447,8098],0); -ELEMENTS[48757] = Fluid3D([7390,6863,7447,8007],0); -ELEMENTS[48758] = Fluid3D([6168,6539,5976,7026],0); -ELEMENTS[48759] = Fluid3D([12051,12843,12129,12745],0); -ELEMENTS[48760] = Fluid3D([13109,12472,12711,11832],0); -ELEMENTS[48761] = Fluid3D([7010,7538,6749,6638],0); -ELEMENTS[48762] = Fluid3D([13541,14357,13628,13945],0); -ELEMENTS[48763] = Fluid3D([13949,13476,13699,12756],0); -ELEMENTS[48764] = Fluid3D([16599,16660,16666,17117],0); -ELEMENTS[48765] = Fluid3D([18321,18377,18471,18466],0); -ELEMENTS[48766] = Fluid3D([5567,5129,5095,5442],0); -ELEMENTS[48767] = Fluid3D([15949,15650,15709,15056],0); -ELEMENTS[48768] = Fluid3D([9229,9390,8800,9748],0); -ELEMENTS[48769] = Fluid3D([9863,10309,10110,8962],0); -ELEMENTS[48770] = Fluid3D([15296,14840,15295,15608],0); -ELEMENTS[48771] = Fluid3D([15296,14840,15608,15190],0); -ELEMENTS[48772] = Fluid3D([7116,7236,6447,7182],0); -ELEMENTS[48773] = Fluid3D([8789,8188,8927,7644],0); -ELEMENTS[48774] = Fluid3D([5416,5609,6215,6030],0); -ELEMENTS[48775] = Fluid3D([10858,10591,11682,10747],0); -ELEMENTS[48776] = Fluid3D([10858,10591,10747,9614],0); -ELEMENTS[48777] = Fluid3D([2390,2610,2654,2577],0); -ELEMENTS[48778] = Fluid3D([15345,14850,15381,15250],0); -ELEMENTS[48779] = Fluid3D([15345,14850,15250,15054],0); -ELEMENTS[48780] = Fluid3D([14850,15381,15250,15346],0); -ELEMENTS[48781] = Fluid3D([10242,9858,9223,9681],0); -ELEMENTS[48782] = Fluid3D([6271,6367,6618,7181],0); -ELEMENTS[48783] = Fluid3D([14771,14243,13962,14683],0); -ELEMENTS[48784] = Fluid3D([8772,8809,9608,8666],0); -ELEMENTS[48785] = Fluid3D([4408,4905,4676,4405],0); -ELEMENTS[48786] = Fluid3D([7095,7195,6836,7722],0); -ELEMENTS[48787] = Fluid3D([14616,14799,14315,14286],0); -ELEMENTS[48788] = Fluid3D([14799,14315,14286,14855],0); -ELEMENTS[48789] = Fluid3D([14616,14799,14286,14507],0); -ELEMENTS[48790] = Fluid3D([14803,15231,15193,15076],0); -ELEMENTS[48791] = Fluid3D([3675,3643,3388,3913],0); -ELEMENTS[48792] = Fluid3D([10487,9713,9712,9392],0); -ELEMENTS[48793] = Fluid3D([8723,7874,7895,8433],0); -ELEMENTS[48794] = Fluid3D([7874,7895,8433,7663],0); -ELEMENTS[48795] = Fluid3D([8723,7874,8433,7825],0); -ELEMENTS[48796] = Fluid3D([15273,15229,15133,14552],0); -ELEMENTS[48797] = Fluid3D([10908,11443,10269,11256],0); -ELEMENTS[48798] = Fluid3D([13085,13207,13818,12891],0); -ELEMENTS[48799] = Fluid3D([12503,13096,13756,13858],0); -ELEMENTS[48800] = Fluid3D([5373,5766,5165,5843],0); -ELEMENTS[48801] = Fluid3D([5373,5766,5843,6247],0); -ELEMENTS[48802] = Fluid3D([13100,12247,13252,13303],0); -ELEMENTS[48803] = Fluid3D([14759,15010,15054,14398],0); -ELEMENTS[48804] = Fluid3D([6403,6466,6827,5707],0); -ELEMENTS[48805] = Fluid3D([15735,15272,15839,15087],0); -ELEMENTS[48806] = Fluid3D([2271,2260,2537,2334],0); -ELEMENTS[48807] = Fluid3D([2271,2260,2334,2080],0); -ELEMENTS[48808] = Fluid3D([2260,2334,2080,2142],0); -ELEMENTS[48809] = Fluid3D([2260,2334,2142,2413],0); -ELEMENTS[48810] = Fluid3D([5069,5541,5421,5663],0); -ELEMENTS[48811] = Fluid3D([6340,6657,6112,5687],0); -ELEMENTS[48812] = Fluid3D([17576,17817,17742,17976],0); -ELEMENTS[48813] = Fluid3D([4639,4818,4952,4326],0); -ELEMENTS[48814] = Fluid3D([15851,15885,15641,16250],0); -ELEMENTS[48815] = Fluid3D([8987,8203,8335,9173],0); -ELEMENTS[48816] = Fluid3D([6264,6253,6862,6984],0); -ELEMENTS[48817] = Fluid3D([10767,10310,9702,9371],0); -ELEMENTS[48818] = Fluid3D([5949,5688,6457,5909],0); -ELEMENTS[48819] = Fluid3D([15443,15074,14892,15014],0); -ELEMENTS[48820] = Fluid3D([7704,7900,8491,7487],0); -ELEMENTS[48821] = Fluid3D([7372,7917,7243,6855],0); -ELEMENTS[48822] = Fluid3D([13800,14621,14298,14082],0); -ELEMENTS[48823] = Fluid3D([1956,1869,1997,2083],0); -ELEMENTS[48824] = Fluid3D([7337,6806,7310,7976],0); -ELEMENTS[48825] = Fluid3D([8396,8170,9069,8342],0); -ELEMENTS[48826] = Fluid3D([8794,8994,9702,9440],0); -ELEMENTS[48827] = Fluid3D([18208,18101,18264,18276],0); -ELEMENTS[48828] = Fluid3D([5616,6254,6004,6540],0); -ELEMENTS[48829] = Fluid3D([16033,15763,16420,16048],0); -ELEMENTS[48830] = Fluid3D([13383,13543,12816,13771],0); -ELEMENTS[48831] = Fluid3D([18367,18123,18217,18198],0); -ELEMENTS[48832] = Fluid3D([18367,18123,18198,18179],0); -ELEMENTS[48833] = Fluid3D([11324,11741,11879,11089],0); -ELEMENTS[48834] = Fluid3D([14015,13051,14138,14023],0); -ELEMENTS[48835] = Fluid3D([12423,11969,11540,12164],0); -ELEMENTS[48836] = Fluid3D([15505,16030,15339,15455],0); -ELEMENTS[48837] = Fluid3D([12927,12147,12057,13225],0); -ELEMENTS[48838] = Fluid3D([11358,12103,11205,11655],0); -ELEMENTS[48839] = Fluid3D([12103,11205,11655,12072],0); -ELEMENTS[48840] = Fluid3D([11205,11358,11655,11247],0); -ELEMENTS[48841] = Fluid3D([11655,11205,11247,10643],0); -ELEMENTS[48842] = Fluid3D([11655,11205,10643,11078],0); -ELEMENTS[48843] = Fluid3D([11205,11358,11247,10383],0); -ELEMENTS[48844] = Fluid3D([11358,11247,10383,10871],0); -ELEMENTS[48845] = Fluid3D([11205,11358,10383,10613],0); -ELEMENTS[48846] = Fluid3D([11247,11205,10383,10643],0); -ELEMENTS[48847] = Fluid3D([16082,15837,16423,16192],0); -ELEMENTS[48848] = Fluid3D([5835,6250,6297,5661],0); -ELEMENTS[48849] = Fluid3D([7078,6867,6050,6563],0); -ELEMENTS[48850] = Fluid3D([6867,6050,6563,5945],0); -ELEMENTS[48851] = Fluid3D([6050,6563,5945,5843],0); -ELEMENTS[48852] = Fluid3D([4363,4669,4800,5115],0); -ELEMENTS[48853] = Fluid3D([9573,10186,9588,9818],0); -ELEMENTS[48854] = Fluid3D([14202,14446,13753,13353],0); -ELEMENTS[48855] = Fluid3D([14446,13753,13353,13250],0); -ELEMENTS[48856] = Fluid3D([13753,14202,13353,13125],0); -ELEMENTS[48857] = Fluid3D([13353,13753,13125,12878],0); -ELEMENTS[48858] = Fluid3D([10566,11388,10829,10674],0); -ELEMENTS[48859] = Fluid3D([10566,11388,10674,11717],0); -ELEMENTS[48860] = Fluid3D([11529,12176,11977,11186],0); -ELEMENTS[48861] = Fluid3D([7536,7515,7791,8378],0); -ELEMENTS[48862] = Fluid3D([6637,6531,7059,7495],0); -ELEMENTS[48863] = Fluid3D([5184,5132,5682,4811],0); -ELEMENTS[48864] = Fluid3D([5184,5132,4811,4463],0); -ELEMENTS[48865] = Fluid3D([7171,8073,8216,7649],0); -ELEMENTS[48866] = Fluid3D([8073,8216,7649,8165],0); -ELEMENTS[48867] = Fluid3D([8216,7649,8165,7608],0); -ELEMENTS[48868] = Fluid3D([7649,8073,8165,7461],0); -ELEMENTS[48869] = Fluid3D([7649,8073,7461,7171],0); -ELEMENTS[48870] = Fluid3D([8165,7649,7461,7376],0); -ELEMENTS[48871] = Fluid3D([8165,7649,7376,7608],0); -ELEMENTS[48872] = Fluid3D([12918,12100,13036,11997],0); -ELEMENTS[48873] = Fluid3D([12085,12943,12977,13161],0); -ELEMENTS[48874] = Fluid3D([5830,5808,5993,6677],0); -ELEMENTS[48875] = Fluid3D([16116,15828,15344,15722],0); -ELEMENTS[48876] = Fluid3D([16116,15828,15722,16065],0); -ELEMENTS[48877] = Fluid3D([15722,16116,16065,15784],0); -ELEMENTS[48878] = Fluid3D([15828,15344,15722,15162],0); -ELEMENTS[48879] = Fluid3D([15344,15722,15162,15784],0); -ELEMENTS[48880] = Fluid3D([16065,15722,15784,15162],0); -ELEMENTS[48881] = Fluid3D([16065,15722,15162,15852],0); -ELEMENTS[48882] = Fluid3D([16065,15722,15852,15828],0); -ELEMENTS[48883] = Fluid3D([11652,11397,10818,11433],0); -ELEMENTS[48884] = Fluid3D([8623,7633,8367,8272],0); -ELEMENTS[48885] = Fluid3D([17498,17050,17285,17375],0); -ELEMENTS[48886] = Fluid3D([17285,17498,17375,17554],0); -ELEMENTS[48887] = Fluid3D([4142,3660,3579,3928],0); -ELEMENTS[48888] = Fluid3D([3660,3579,3928,3544],0); -ELEMENTS[48889] = Fluid3D([14419,14461,13733,13746],0); -ELEMENTS[48890] = Fluid3D([18603,18525,18571,18431],0); -ELEMENTS[48891] = Fluid3D([14369,14484,13790,13836],0); -ELEMENTS[48892] = Fluid3D([8094,8231,7260,7600],0); -ELEMENTS[48893] = Fluid3D([15282,14864,15447,15656],0); -ELEMENTS[48894] = Fluid3D([14908,14943,15545,14938],0); -ELEMENTS[48895] = Fluid3D([17977,18113,18261,18085],0); -ELEMENTS[48896] = Fluid3D([17977,18113,18085,17915],0); -ELEMENTS[48897] = Fluid3D([18261,17977,18085,18236],0); -ELEMENTS[48898] = Fluid3D([2532,2514,2318,2272],0); -ELEMENTS[48899] = Fluid3D([14353,14148,14674,13851],0); -ELEMENTS[48900] = Fluid3D([13009,12065,12466,12144],0); -ELEMENTS[48901] = Fluid3D([8437,8586,8796,9384],0); -ELEMENTS[48902] = Fluid3D([8965,9669,9858,9223],0); -ELEMENTS[48903] = Fluid3D([3027,3223,3108,2774],0); -ELEMENTS[48904] = Fluid3D([2313,2151,2187,2453],0); -ELEMENTS[48905] = Fluid3D([7076,6319,6768,6097],0); -ELEMENTS[48906] = Fluid3D([13621,14511,14394,13981],0); -ELEMENTS[48907] = Fluid3D([13621,14511,13981,14254],0); -ELEMENTS[48908] = Fluid3D([13981,13621,14254,13795],0); -ELEMENTS[48909] = Fluid3D([11458,11573,11362,12202],0); -ELEMENTS[48910] = Fluid3D([17955,18042,17728,18018],0); -ELEMENTS[48911] = Fluid3D([12250,11968,12747,12243],0); -ELEMENTS[48912] = Fluid3D([7605,7059,7105,8104],0); -ELEMENTS[48913] = Fluid3D([12577,13000,12332,12989],0); -ELEMENTS[48914] = Fluid3D([12332,12577,12989,11936],0); -ELEMENTS[48915] = Fluid3D([12989,12332,11936,12381],0); -ELEMENTS[48916] = Fluid3D([12332,12577,11936,11516],0); -ELEMENTS[48917] = Fluid3D([2902,3120,2607,2916],0); -ELEMENTS[48918] = Fluid3D([2902,3120,2916,3092],0); -ELEMENTS[48919] = Fluid3D([2607,2902,2916,2765],0); -ELEMENTS[48920] = Fluid3D([2902,2916,2765,3092],0); -ELEMENTS[48921] = Fluid3D([2916,2607,2765,2845],0); -ELEMENTS[48922] = Fluid3D([2765,2916,2845,3089],0); -ELEMENTS[48923] = Fluid3D([2765,2916,3089,3092],0); -ELEMENTS[48924] = Fluid3D([3089,2765,3092,2941],0); -ELEMENTS[48925] = Fluid3D([3092,3089,2941,3286],0); -ELEMENTS[48926] = Fluid3D([3089,2765,2941,2845],0); -ELEMENTS[48927] = Fluid3D([2916,3089,3092,3317],0); -ELEMENTS[48928] = Fluid3D([3089,3092,3317,3549],0); -ELEMENTS[48929] = Fluid3D([2916,3089,3317,3229],0); -ELEMENTS[48930] = Fluid3D([3317,2916,3229,3120],0); -ELEMENTS[48931] = Fluid3D([3089,3317,3229,3426],0); -ELEMENTS[48932] = Fluid3D([3089,3317,3426,3549],0); -ELEMENTS[48933] = Fluid3D([3317,3426,3549,3471],0); -ELEMENTS[48934] = Fluid3D([3317,3229,3426,3471],0); -ELEMENTS[48935] = Fluid3D([3317,3229,3471,3120],0); -ELEMENTS[48936] = Fluid3D([3471,3317,3120,3257],0); -ELEMENTS[48937] = Fluid3D([3092,3317,3549,3257],0); -ELEMENTS[48938] = Fluid3D([3317,2916,3120,3092],0); -ELEMENTS[48939] = Fluid3D([2916,2845,3089,3229],0); -ELEMENTS[48940] = Fluid3D([3229,3089,3426,3191],0); -ELEMENTS[48941] = Fluid3D([3089,3426,3191,3386],0); -ELEMENTS[48942] = Fluid3D([3426,3089,3549,3286],0); -ELEMENTS[48943] = Fluid3D([5163,4928,5598,5027],0); -ELEMENTS[48944] = Fluid3D([10569,11014,11246,11366],0); -ELEMENTS[48945] = Fluid3D([9943,10306,10770,10144],0); -ELEMENTS[48946] = Fluid3D([11688,12260,12468,11712],0); -ELEMENTS[48947] = Fluid3D([12468,11688,11712,11183],0); -ELEMENTS[48948] = Fluid3D([11688,12260,11712,11044],0); -ELEMENTS[48949] = Fluid3D([11688,11712,11183,11044],0); -ELEMENTS[48950] = Fluid3D([11712,11183,11044,11111],0); -ELEMENTS[48951] = Fluid3D([11712,11183,11111,11918],0); -ELEMENTS[48952] = Fluid3D([11044,11712,11111,12128],0); -ELEMENTS[48953] = Fluid3D([11712,11111,12128,11918],0); -ELEMENTS[48954] = Fluid3D([11044,11712,12128,12260],0); -ELEMENTS[48955] = Fluid3D([11712,12128,12260,12468],0); -ELEMENTS[48956] = Fluid3D([11712,12468,11183,12055],0); -ELEMENTS[48957] = Fluid3D([11183,11712,12055,11918],0); -ELEMENTS[48958] = Fluid3D([11712,12468,12055,12128],0); -ELEMENTS[48959] = Fluid3D([17001,16914,17344,17253],0); -ELEMENTS[48960] = Fluid3D([10116,9689,10001,10921],0); -ELEMENTS[48961] = Fluid3D([17402,17547,17718,17550],0); -ELEMENTS[48962] = Fluid3D([14230,14576,15114,14660],0); -ELEMENTS[48963] = Fluid3D([6860,6192,6667,6634],0); -ELEMENTS[48964] = Fluid3D([6667,6860,6634,7376],0); -ELEMENTS[48965] = Fluid3D([6860,6634,7376,7608],0); -ELEMENTS[48966] = Fluid3D([6860,6192,6634,6524],0); -ELEMENTS[48967] = Fluid3D([6634,6860,6524,7608],0); -ELEMENTS[48968] = Fluid3D([9794,9512,10368,10686],0); -ELEMENTS[48969] = Fluid3D([6198,6105,5648,6657],0); -ELEMENTS[48970] = Fluid3D([16590,16581,16449,16088],0); -ELEMENTS[48971] = Fluid3D([6639,7289,6682,7275],0); -ELEMENTS[48972] = Fluid3D([13548,12958,13210,14194],0); -ELEMENTS[48973] = Fluid3D([5249,4782,5168,4978],0); -ELEMENTS[48974] = Fluid3D([13573,14078,13882,13269],0); -ELEMENTS[48975] = Fluid3D([12103,11655,12618,12072],0); -ELEMENTS[48976] = Fluid3D([14065,14809,14664,14310],0); -ELEMENTS[48977] = Fluid3D([5148,4998,5509,5561],0); -ELEMENTS[48978] = Fluid3D([5509,5148,5561,5476],0); -ELEMENTS[48979] = Fluid3D([5148,5561,5476,5015],0); -ELEMENTS[48980] = Fluid3D([5561,5476,5015,5118],0); -ELEMENTS[48981] = Fluid3D([5148,5561,5015,4998],0); -ELEMENTS[48982] = Fluid3D([5561,5015,4998,5118],0); -ELEMENTS[48983] = Fluid3D([5015,4998,5118,4619],0); -ELEMENTS[48984] = Fluid3D([5118,5015,4619,5476],0); -ELEMENTS[48985] = Fluid3D([5015,4998,4619,4692],0); -ELEMENTS[48986] = Fluid3D([4619,5015,4692,5476],0); -ELEMENTS[48987] = Fluid3D([5015,4692,5476,5148],0); -ELEMENTS[48988] = Fluid3D([5015,4692,5148,4998],0); -ELEMENTS[48989] = Fluid3D([8197,7994,7641,8483],0); -ELEMENTS[48990] = Fluid3D([9418,9954,8814,8720],0); -ELEMENTS[48991] = Fluid3D([2567,2281,2402,2317],0); -ELEMENTS[48992] = Fluid3D([2281,2402,2317,2123],0); -ELEMENTS[48993] = Fluid3D([2317,2281,2123,2156],0); -ELEMENTS[48994] = Fluid3D([2317,2281,2156,2366],0); -ELEMENTS[48995] = Fluid3D([2281,2123,2156,1992],0); -ELEMENTS[48996] = Fluid3D([2567,2281,2317,2366],0); -ELEMENTS[48997] = Fluid3D([2281,2156,2366,2226],0); -ELEMENTS[48998] = Fluid3D([2281,2156,2226,1992],0); -ELEMENTS[48999] = Fluid3D([4941,4946,5136,4617],0); -ELEMENTS[49000] = Fluid3D([5136,4941,4617,4837],0); -ELEMENTS[49001] = Fluid3D([4941,4617,4837,4413],0); -ELEMENTS[49002] = Fluid3D([12215,12525,12287,13146],0); -ELEMENTS[49003] = Fluid3D([12525,12287,13146,12702],0); -ELEMENTS[49004] = Fluid3D([15909,16340,16527,15864],0); -ELEMENTS[49005] = Fluid3D([11003,10085,10477,10390],0); -ELEMENTS[49006] = Fluid3D([16086,16139,16542,15974],0); -ELEMENTS[49007] = Fluid3D([4543,4490,4039,4206],0); -ELEMENTS[49008] = Fluid3D([17326,16984,17548,17243],0); -ELEMENTS[49009] = Fluid3D([4987,5045,5234,5573],0); -ELEMENTS[49010] = Fluid3D([4987,5045,5573,5518],0); -ELEMENTS[49011] = Fluid3D([5573,4987,5518,5611],0); -ELEMENTS[49012] = Fluid3D([16023,15791,15872,15677],0); -ELEMENTS[49013] = Fluid3D([13453,13369,12646,13097],0); -ELEMENTS[49014] = Fluid3D([14639,14366,14422,13578],0); -ELEMENTS[49015] = Fluid3D([3319,3124,3053,2914],0); -ELEMENTS[49016] = Fluid3D([3336,3505,3473,4032],0); -ELEMENTS[49017] = Fluid3D([16206,16409,15774,15824],0); -ELEMENTS[49018] = Fluid3D([9634,9052,9657,10515],0); -ELEMENTS[49019] = Fluid3D([10457,10372,10109,11118],0); -ELEMENTS[49020] = Fluid3D([15745,15795,16304,16239],0); -ELEMENTS[49021] = Fluid3D([7881,8128,7330,7468],0); -ELEMENTS[49022] = Fluid3D([7881,8128,7468,8266],0); -ELEMENTS[49023] = Fluid3D([7330,7881,7468,6680],0); -ELEMENTS[49024] = Fluid3D([13226,12708,13344,13835],0); -ELEMENTS[49025] = Fluid3D([12475,12811,12627,13660],0); -ELEMENTS[49026] = Fluid3D([8141,7920,7679,8390],0); -ELEMENTS[49027] = Fluid3D([3191,2940,2845,2630],0); -ELEMENTS[49028] = Fluid3D([17949,17640,17810,18103],0); -ELEMENTS[49029] = Fluid3D([12755,12496,12998,13494],0); -ELEMENTS[49030] = Fluid3D([5051,5592,4994,5555],0); -ELEMENTS[49031] = Fluid3D([12039,12517,12218,13244],0); -ELEMENTS[49032] = Fluid3D([4964,4546,4570,4742],0); -ELEMENTS[49033] = Fluid3D([15780,15974,15667,15358],0); -ELEMENTS[49034] = Fluid3D([15974,15667,15358,15093],0); -ELEMENTS[49035] = Fluid3D([15667,15358,15093,14882],0); -ELEMENTS[49036] = Fluid3D([15358,15093,14882,14656],0); -ELEMENTS[49037] = Fluid3D([15358,15093,14656,15294],0); -ELEMENTS[49038] = Fluid3D([15358,15093,15294,15974],0); -ELEMENTS[49039] = Fluid3D([14656,15358,15294,14815],0); -ELEMENTS[49040] = Fluid3D([15780,15974,15358,15566],0); -ELEMENTS[49041] = Fluid3D([15358,15780,15566,14815],0); -ELEMENTS[49042] = Fluid3D([15566,15358,14815,15294],0); -ELEMENTS[49043] = Fluid3D([15566,15358,15294,15974],0); -ELEMENTS[49044] = Fluid3D([11654,11601,11948,12840],0); -ELEMENTS[49045] = Fluid3D([11933,12424,12835,12328],0); -ELEMENTS[49046] = Fluid3D([5934,5525,5845,6412],0); -ELEMENTS[49047] = Fluid3D([8514,8763,7659,8033],0); -ELEMENTS[49048] = Fluid3D([6488,7124,7189,6449],0); -ELEMENTS[49049] = Fluid3D([8347,9287,9108,8979],0); -ELEMENTS[49050] = Fluid3D([16150,16273,16646,16814],0); -ELEMENTS[49051] = Fluid3D([11969,12931,12670,12883],0); -ELEMENTS[49052] = Fluid3D([7226,6526,6718,7319],0); -ELEMENTS[49053] = Fluid3D([11335,12109,11525,11411],0); -ELEMENTS[49054] = Fluid3D([11525,11335,11411,10624],0); -ELEMENTS[49055] = Fluid3D([11411,11525,10624,10811],0); -ELEMENTS[49056] = Fluid3D([11525,11335,10624,11324],0); -ELEMENTS[49057] = Fluid3D([16163,16092,16026,15390],0); -ELEMENTS[49058] = Fluid3D([14404,14237,13926,15133],0); -ELEMENTS[49059] = Fluid3D([4978,4750,4516,5093],0); -ELEMENTS[49060] = Fluid3D([15841,15530,15616,14811],0); -ELEMENTS[49061] = Fluid3D([10469,10538,10376,11421],0); -ELEMENTS[49062] = Fluid3D([10451,10145,10628,10079],0); -ELEMENTS[49063] = Fluid3D([10451,10145,10079,9357],0); -ELEMENTS[49064] = Fluid3D([9142,9481,10116,10001],0); -ELEMENTS[49065] = Fluid3D([14961,14790,14138,14023],0); -ELEMENTS[49066] = Fluid3D([3918,3525,3655,3660],0); -ELEMENTS[49067] = Fluid3D([11025,10983,10618,11410],0); -ELEMENTS[49068] = Fluid3D([11025,10983,11410,11829],0); -ELEMENTS[49069] = Fluid3D([10618,11025,11410,11680],0); -ELEMENTS[49070] = Fluid3D([11410,11025,11829,11680],0); -ELEMENTS[49071] = Fluid3D([10777,9824,10745,9931],0); -ELEMENTS[49072] = Fluid3D([9824,10745,9931,9734],0); -ELEMENTS[49073] = Fluid3D([10777,9824,9931,10414],0); -ELEMENTS[49074] = Fluid3D([16155,15837,15582,15600],0); -ELEMENTS[49075] = Fluid3D([15736,15668,15537,16195],0); -ELEMENTS[49076] = Fluid3D([5213,4757,4602,5292],0); -ELEMENTS[49077] = Fluid3D([10112,10910,11293,10403],0); -ELEMENTS[49078] = Fluid3D([15322,14708,15352,15431],0); -ELEMENTS[49079] = Fluid3D([15352,15322,15431,15875],0); -ELEMENTS[49080] = Fluid3D([15322,15431,15875,16048],0); -ELEMENTS[49081] = Fluid3D([15431,15352,15875,15987],0); -ELEMENTS[49082] = Fluid3D([9042,9299,9724,9836],0); -ELEMENTS[49083] = Fluid3D([9481,9358,10119,10093],0); -ELEMENTS[49084] = Fluid3D([16934,17056,16793,16751],0); -ELEMENTS[49085] = Fluid3D([16934,17056,16751,16723],0); -ELEMENTS[49086] = Fluid3D([16793,16934,16751,16407],0); -ELEMENTS[49087] = Fluid3D([17056,16793,16751,16923],0); -ELEMENTS[49088] = Fluid3D([16934,16751,16407,16723],0); -ELEMENTS[49089] = Fluid3D([15168,14445,14300,15046],0); -ELEMENTS[49090] = Fluid3D([12652,12415,11952,12794],0); -ELEMENTS[49091] = Fluid3D([7742,8596,8312,7502],0); -ELEMENTS[49092] = Fluid3D([11040,11076,10394,10939],0); -ELEMENTS[49093] = Fluid3D([17253,17116,17001,16914],0); -ELEMENTS[49094] = Fluid3D([3738,4182,3717,3945],0); -ELEMENTS[49095] = Fluid3D([9289,9379,10410,9559],0); -ELEMENTS[49096] = Fluid3D([14617,14379,14798,15175],0); -ELEMENTS[49097] = Fluid3D([15907,15947,15911,15514],0); -ELEMENTS[49098] = Fluid3D([10187,10381,9892,11203],0); -ELEMENTS[49099] = Fluid3D([17086,17503,17384,17131],0); -ELEMENTS[49100] = Fluid3D([17903,17912,17653,17586],0); -ELEMENTS[49101] = Fluid3D([10960,10926,11739,12310],0); -ELEMENTS[49102] = Fluid3D([6153,5669,5367,5622],0); -ELEMENTS[49103] = Fluid3D([4629,4661,4276,4763],0); -ELEMENTS[49104] = Fluid3D([4434,4399,4215,3993],0); -ELEMENTS[49105] = Fluid3D([15459,16001,15847,15163],0); -ELEMENTS[49106] = Fluid3D([4990,5423,5737,5317],0); -ELEMENTS[49107] = Fluid3D([4990,5423,5317,4983],0); -ELEMENTS[49108] = Fluid3D([5423,5737,5317,5754],0); -ELEMENTS[49109] = Fluid3D([5317,5423,5754,5313],0); -ELEMENTS[49110] = Fluid3D([5737,5317,5754,5796],0); -ELEMENTS[49111] = Fluid3D([10383,10212,9596,9656],0); -ELEMENTS[49112] = Fluid3D([18292,18398,18421,18435],0); -ELEMENTS[49113] = Fluid3D([18292,18398,18435,18404],0); -ELEMENTS[49114] = Fluid3D([18398,18435,18404,18519],0); -ELEMENTS[49115] = Fluid3D([18404,18398,18519,18494],0); -ELEMENTS[49116] = Fluid3D([18398,18435,18519,18421],0); -ELEMENTS[49117] = Fluid3D([18398,18519,18494,18458],0); -ELEMENTS[49118] = Fluid3D([18398,18519,18458,18421],0); -ELEMENTS[49119] = Fluid3D([18519,18494,18458,18576],0); -ELEMENTS[49120] = Fluid3D([18458,18519,18576,18597],0); -ELEMENTS[49121] = Fluid3D([18494,18398,18458,18222],0); -ELEMENTS[49122] = Fluid3D([9744,10051,10781,9913],0); -ELEMENTS[49123] = Fluid3D([10051,10781,9913,10678],0); -ELEMENTS[49124] = Fluid3D([9744,10051,9913,8925],0); -ELEMENTS[49125] = Fluid3D([12436,13054,12574,12321],0); -ELEMENTS[49126] = Fluid3D([11658,11389,11910,11052],0); -ELEMENTS[49127] = Fluid3D([6767,6295,6839,6247],0); -ELEMENTS[49128] = Fluid3D([6767,6295,6247,6519],0); -ELEMENTS[49129] = Fluid3D([6295,6839,6247,6475],0); -ELEMENTS[49130] = Fluid3D([14667,15184,14839,15574],0); -ELEMENTS[49131] = Fluid3D([14143,14651,14305,14976],0); -ELEMENTS[49132] = Fluid3D([14143,14651,14976,14557],0); -ELEMENTS[49133] = Fluid3D([17179,17186,16958,17477],0); -ELEMENTS[49134] = Fluid3D([16780,16620,16980,16870],0); -ELEMENTS[49135] = Fluid3D([16620,16980,16870,16789],0); -ELEMENTS[49136] = Fluid3D([10234,11062,10239,9475],0); -ELEMENTS[49137] = Fluid3D([7306,7983,7966,8046],0); -ELEMENTS[49138] = Fluid3D([6767,6798,6027,6519],0); -ELEMENTS[49139] = Fluid3D([3106,2843,3074,2980],0); -ELEMENTS[49140] = Fluid3D([3106,2843,2980,2823],0); -ELEMENTS[49141] = Fluid3D([9177,8639,9385,8858],0); -ELEMENTS[49142] = Fluid3D([18138,18019,18147,18316],0); -ELEMENTS[49143] = Fluid3D([18138,18019,18316,18283],0); -ELEMENTS[49144] = Fluid3D([18316,18138,18283,18298],0); -ELEMENTS[49145] = Fluid3D([9529,9464,9189,10399],0); -ELEMENTS[49146] = Fluid3D([14343,14125,14665,14149],0); -ELEMENTS[49147] = Fluid3D([14125,14665,14149,13791],0); -ELEMENTS[49148] = Fluid3D([7133,7156,6370,6491],0); -ELEMENTS[49149] = Fluid3D([5727,5227,4980,5424],0); -ELEMENTS[49150] = Fluid3D([5227,4980,5424,4903],0); -ELEMENTS[49151] = Fluid3D([5227,4980,4903,4469],0); -ELEMENTS[49152] = Fluid3D([5424,5227,4903,5775],0); -ELEMENTS[49153] = Fluid3D([14677,14939,14209,14184],0); -ELEMENTS[49154] = Fluid3D([17123,17429,17168,17296],0); -ELEMENTS[49155] = Fluid3D([17123,17429,17296,17322],0); -ELEMENTS[49156] = Fluid3D([17429,17168,17296,17433],0); -ELEMENTS[49157] = Fluid3D([17289,17434,17560,17297],0); -ELEMENTS[49158] = Fluid3D([13142,13733,12787,13049],0); -ELEMENTS[49159] = Fluid3D([11741,10708,10529,10701],0); -ELEMENTS[49160] = Fluid3D([10708,10529,10701,10290],0); -ELEMENTS[49161] = Fluid3D([10701,10708,10290,11324],0); -ELEMENTS[49162] = Fluid3D([10290,10701,11324,10624],0); -ELEMENTS[49163] = Fluid3D([10708,10529,10290,9396],0); -ELEMENTS[49164] = Fluid3D([10529,10701,10290,10104],0); -ELEMENTS[49165] = Fluid3D([10701,10708,11324,11741],0); -ELEMENTS[49166] = Fluid3D([11324,10701,11741,11089],0); -ELEMENTS[49167] = Fluid3D([6660,6355,6458,5855],0); -ELEMENTS[49168] = Fluid3D([10377,11115,10776,10215],0); -ELEMENTS[49169] = Fluid3D([3483,3230,2985,3214],0); -ELEMENTS[49170] = Fluid3D([3483,3230,3214,3430],0); -ELEMENTS[49171] = Fluid3D([3483,3230,3430,3508],0); -ELEMENTS[49172] = Fluid3D([3214,3483,3430,3820],0); -ELEMENTS[49173] = Fluid3D([8326,9128,9103,8515],0); -ELEMENTS[49174] = Fluid3D([12656,12141,11693,11387],0); -ELEMENTS[49175] = Fluid3D([15126,14918,14507,15277],0); -ELEMENTS[49176] = Fluid3D([11245,12021,11701,10550],0); -ELEMENTS[49177] = Fluid3D([12776,12642,12493,11676],0); -ELEMENTS[49178] = Fluid3D([9535,8672,8844,8721],0); -ELEMENTS[49179] = Fluid3D([12436,12632,12024,11731],0); -ELEMENTS[49180] = Fluid3D([12436,12632,11731,12574],0); -ELEMENTS[49181] = Fluid3D([13443,13301,13984,13143],0); -ELEMENTS[49182] = Fluid3D([13443,13301,13143,12430],0); -ELEMENTS[49183] = Fluid3D([13301,13143,12430,13710],0); -ELEMENTS[49184] = Fluid3D([13301,13143,13710,13984],0); -ELEMENTS[49185] = Fluid3D([13143,13443,12430,13254],0); -ELEMENTS[49186] = Fluid3D([13143,13443,13254,13984],0); -ELEMENTS[49187] = Fluid3D([13443,13254,13984,13893],0); -ELEMENTS[49188] = Fluid3D([13443,13254,13893,13889],0); -ELEMENTS[49189] = Fluid3D([13143,12430,13710,12748],0); -ELEMENTS[49190] = Fluid3D([13143,12430,12748,12374],0); -ELEMENTS[49191] = Fluid3D([12748,13143,12374,12974],0); -ELEMENTS[49192] = Fluid3D([12748,13143,12974,13710],0); -ELEMENTS[49193] = Fluid3D([13143,12430,12374,13254],0); -ELEMENTS[49194] = Fluid3D([13254,13984,13893,13605],0); -ELEMENTS[49195] = Fluid3D([13893,13254,13605,13909],0); -ELEMENTS[49196] = Fluid3D([13605,13893,13909,13984],0); -ELEMENTS[49197] = Fluid3D([12374,13143,13254,12974],0); -ELEMENTS[49198] = Fluid3D([13443,13254,13889,13114],0); -ELEMENTS[49199] = Fluid3D([13443,13254,13114,12668],0); -ELEMENTS[49200] = Fluid3D([13443,13254,12668,12430],0); -ELEMENTS[49201] = Fluid3D([13143,13710,13984,12974],0); -ELEMENTS[49202] = Fluid3D([12668,13443,12430,13301],0); -ELEMENTS[49203] = Fluid3D([13984,13443,13893,14173],0); -ELEMENTS[49204] = Fluid3D([10092,9351,9659,9860],0); -ELEMENTS[49205] = Fluid3D([14888,15593,14992,15440],0); -ELEMENTS[49206] = Fluid3D([4614,4529,4493,4906],0); -ELEMENTS[49207] = Fluid3D([11402,10795,11261,12120],0); -ELEMENTS[49208] = Fluid3D([2468,2654,2828,2577],0); -ELEMENTS[49209] = Fluid3D([4721,5204,5409,5202],0); -ELEMENTS[49210] = Fluid3D([11490,11371,12414,11884],0); -ELEMENTS[49211] = Fluid3D([1880,2010,2098,2087],0); -ELEMENTS[49212] = Fluid3D([5726,6277,5851,6812],0); -ELEMENTS[49213] = Fluid3D([15287,15593,15781,16129],0); -ELEMENTS[49214] = Fluid3D([15593,15781,16129,15857],0); -ELEMENTS[49215] = Fluid3D([15593,15781,15857,15440],0); -ELEMENTS[49216] = Fluid3D([16129,15593,15857,16261],0); -ELEMENTS[49217] = Fluid3D([15857,15593,15440,14992],0); -ELEMENTS[49218] = Fluid3D([15226,14888,14992,14072],0); -ELEMENTS[49219] = Fluid3D([6020,6493,6869,7040],0); -ELEMENTS[49220] = Fluid3D([6493,6869,7040,7431],0); -ELEMENTS[49221] = Fluid3D([17056,16891,17164,16780],0); -ELEMENTS[49222] = Fluid3D([12612,11924,12062,12751],0); -ELEMENTS[49223] = Fluid3D([13138,12331,13041,13649],0); -ELEMENTS[49224] = Fluid3D([11604,12326,12348,12711],0); -ELEMENTS[49225] = Fluid3D([17943,18069,17830,17747],0); -ELEMENTS[49226] = Fluid3D([12394,13053,13027,13691],0); -ELEMENTS[49227] = Fluid3D([2098,2275,2171,2010],0); -ELEMENTS[49228] = Fluid3D([2171,2098,2010,2087],0); -ELEMENTS[49229] = Fluid3D([14628,14826,14285,14676],0); -ELEMENTS[49230] = Fluid3D([18507,18572,18594,18626],0); -ELEMENTS[49231] = Fluid3D([11517,10562,11837,11467],0); -ELEMENTS[49232] = Fluid3D([18211,18301,18441,18192],0); -ELEMENTS[49233] = Fluid3D([18211,18301,18192,18034],0); -ELEMENTS[49234] = Fluid3D([4433,4052,4467,4756],0); -ELEMENTS[49235] = Fluid3D([9980,9933,10297,10819],0); -ELEMENTS[49236] = Fluid3D([9980,9933,10819,10755],0); -ELEMENTS[49237] = Fluid3D([3355,3191,3640,3768],0); -ELEMENTS[49238] = Fluid3D([4207,4512,4907,4288],0); -ELEMENTS[49239] = Fluid3D([9961,10084,10874,9944],0); -ELEMENTS[49240] = Fluid3D([10428,10073,10245,9565],0); -ELEMENTS[49241] = Fluid3D([10428,10073,9565,9225],0); -ELEMENTS[49242] = Fluid3D([11177,11901,10829,11345],0); -ELEMENTS[49243] = Fluid3D([5581,5226,5545,5855],0); -ELEMENTS[49244] = Fluid3D([15308,14798,15398,15380],0); -ELEMENTS[49245] = Fluid3D([15308,14798,15380,15338],0); -ELEMENTS[49246] = Fluid3D([13092,13779,12813,13271],0); -ELEMENTS[49247] = Fluid3D([13384,13888,13556,14198],0); -ELEMENTS[49248] = Fluid3D([3044,3227,3109,2784],0); -ELEMENTS[49249] = Fluid3D([3044,3227,2784,2895],0); -ELEMENTS[49250] = Fluid3D([3044,3227,2895,3023],0); -ELEMENTS[49251] = Fluid3D([9261,9323,8684,8745],0); -ELEMENTS[49252] = Fluid3D([11285,11098,11083,12217],0); -ELEMENTS[49253] = Fluid3D([8881,7899,9200,8912],0); -ELEMENTS[49254] = Fluid3D([9200,8881,8912,9165],0); -ELEMENTS[49255] = Fluid3D([9200,8881,9165,9865],0); -ELEMENTS[49256] = Fluid3D([9200,8881,9865,9355],0); -ELEMENTS[49257] = Fluid3D([9200,8881,9355,9084],0); -ELEMENTS[49258] = Fluid3D([4039,3807,3509,3590],0); -ELEMENTS[49259] = Fluid3D([17182,17038,17316,17040],0); -ELEMENTS[49260] = Fluid3D([10040,9611,9146,8778],0); -ELEMENTS[49261] = Fluid3D([11451,11594,11954,10767],0); -ELEMENTS[49262] = Fluid3D([11394,11003,11812,10477],0); -ELEMENTS[49263] = Fluid3D([7524,6958,7950,7354],0); -ELEMENTS[49264] = Fluid3D([12583,12752,13422,13245],0); -ELEMENTS[49265] = Fluid3D([10632,10774,10586,9551],0); -ELEMENTS[49266] = Fluid3D([8337,8292,7624,8105],0); -ELEMENTS[49267] = Fluid3D([13140,12442,13484,12591],0); -ELEMENTS[49268] = Fluid3D([8367,8682,8032,8623],0); -ELEMENTS[49269] = Fluid3D([15137,14902,15082,15814],0); -ELEMENTS[49270] = Fluid3D([15624,16241,15888,16070],0); -ELEMENTS[49271] = Fluid3D([2126,2263,2109,1995],0); -ELEMENTS[49272] = Fluid3D([10330,10548,10270,11390],0); -ELEMENTS[49273] = Fluid3D([10548,10270,11390,11365],0); -ELEMENTS[49274] = Fluid3D([8071,7779,7572,8683],0); -ELEMENTS[49275] = Fluid3D([7745,7997,7392,6998],0); -ELEMENTS[49276] = Fluid3D([11570,12549,11823,12015],0); -ELEMENTS[49277] = Fluid3D([6245,6505,6830,7377],0); -ELEMENTS[49278] = Fluid3D([15733,15706,15904,15169],0); -ELEMENTS[49279] = Fluid3D([15097,15420,14950,14555],0); -ELEMENTS[49280] = Fluid3D([8136,7365,7845,8475],0); -ELEMENTS[49281] = Fluid3D([10868,10149,10558,10284],0); -ELEMENTS[49282] = Fluid3D([5403,5188,5804,5576],0); -ELEMENTS[49283] = Fluid3D([15177,15380,15398,14798],0); -ELEMENTS[49284] = Fluid3D([11601,11079,10699,11885],0); -ELEMENTS[49285] = Fluid3D([14797,14273,14619,13904],0); -ELEMENTS[49286] = Fluid3D([6676,6896,6233,6224],0); -ELEMENTS[49287] = Fluid3D([7928,8471,7950,7354],0); -ELEMENTS[49288] = Fluid3D([3658,3795,3459,3584],0); -ELEMENTS[49289] = Fluid3D([13661,13921,13369,12993],0); -ELEMENTS[49290] = Fluid3D([13921,13369,12993,13274],0); -ELEMENTS[49291] = Fluid3D([13921,13369,13274,13829],0); -ELEMENTS[49292] = Fluid3D([13921,13369,13829,14498],0); -ELEMENTS[49293] = Fluid3D([13661,13921,12993,13844],0); -ELEMENTS[49294] = Fluid3D([4708,4369,5076,4771],0); -ELEMENTS[49295] = Fluid3D([5076,4708,4771,5277],0); -ELEMENTS[49296] = Fluid3D([5110,5364,5863,5296],0); -ELEMENTS[49297] = Fluid3D([5110,5364,5296,4874],0); -ELEMENTS[49298] = Fluid3D([5110,5364,4874,4689],0); -ELEMENTS[49299] = Fluid3D([4874,5110,4689,4680],0); -ELEMENTS[49300] = Fluid3D([4083,4532,4320,4509],0); -ELEMENTS[49301] = Fluid3D([17090,16722,17403,16832],0); -ELEMENTS[49302] = Fluid3D([17002,17027,16698,16558],0); -ELEMENTS[49303] = Fluid3D([4580,4232,4662,4361],0); -ELEMENTS[49304] = Fluid3D([7745,7266,7181,6950],0); -ELEMENTS[49305] = Fluid3D([16053,15948,16098,15683],0); -ELEMENTS[49306] = Fluid3D([15948,16098,15683,15545],0); -ELEMENTS[49307] = Fluid3D([15948,16098,15545,16103],0); -ELEMENTS[49308] = Fluid3D([15948,16098,16103,16445],0); -ELEMENTS[49309] = Fluid3D([16103,15948,16445,15545],0); -ELEMENTS[49310] = Fluid3D([16098,16103,16445,16394],0); -ELEMENTS[49311] = Fluid3D([16103,16445,16394,16175],0); -ELEMENTS[49312] = Fluid3D([16103,16445,16175,16122],0); -ELEMENTS[49313] = Fluid3D([16394,16103,16175,15553],0); -ELEMENTS[49314] = Fluid3D([16103,16175,15553,16122],0); -ELEMENTS[49315] = Fluid3D([16103,16445,16122,15545],0); -ELEMENTS[49316] = Fluid3D([16098,16103,16394,15553],0); -ELEMENTS[49317] = Fluid3D([16445,16394,16175,16697],0); -ELEMENTS[49318] = Fluid3D([16394,16175,16697,16106],0); -ELEMENTS[49319] = Fluid3D([16394,16175,16106,15553],0); -ELEMENTS[49320] = Fluid3D([13617,13746,12787,13733],0); -ELEMENTS[49321] = Fluid3D([13617,13746,13733,14623],0); -ELEMENTS[49322] = Fluid3D([17737,17741,17739,17415],0); -ELEMENTS[49323] = Fluid3D([12874,12370,12336,13452],0); -ELEMENTS[49324] = Fluid3D([16725,16299,16305,16266],0); -ELEMENTS[49325] = Fluid3D([16725,16299,16266,16997],0); -ELEMENTS[49326] = Fluid3D([16583,16894,16280,16863],0); -ELEMENTS[49327] = Fluid3D([8754,8599,9330,8804],0); -ELEMENTS[49328] = Fluid3D([8599,9330,8804,9433],0); -ELEMENTS[49329] = Fluid3D([9330,8754,8804,8398],0); -ELEMENTS[49330] = Fluid3D([8804,9330,8398,9175],0); -ELEMENTS[49331] = Fluid3D([11389,11658,10539,11052],0); -ELEMENTS[49332] = Fluid3D([10539,11389,11052,10952],0); -ELEMENTS[49333] = Fluid3D([11275,10923,11640,11958],0); -ELEMENTS[49334] = Fluid3D([11275,10923,11958,10845],0); -ELEMENTS[49335] = Fluid3D([5669,5303,5778,5367],0); -ELEMENTS[49336] = Fluid3D([8809,8522,9608,9228],0); -ELEMENTS[49337] = Fluid3D([9608,8809,9228,8666],0); -ELEMENTS[49338] = Fluid3D([10634,10242,11233,10976],0); -ELEMENTS[49339] = Fluid3D([6374,6237,5715,5812],0); -ELEMENTS[49340] = Fluid3D([6237,5715,5812,5578],0); -ELEMENTS[49341] = Fluid3D([8693,8001,8212,8489],0); -ELEMENTS[49342] = Fluid3D([11863,10919,11673,11958],0); -ELEMENTS[49343] = Fluid3D([7854,8698,8042,7753],0); -ELEMENTS[49344] = Fluid3D([18058,18023,17982,18254],0); -ELEMENTS[49345] = Fluid3D([9477,10356,9478,10255],0); -ELEMENTS[49346] = Fluid3D([12382,11762,11328,11629],0); -ELEMENTS[49347] = Fluid3D([11551,11377,12408,11607],0); -ELEMENTS[49348] = Fluid3D([9707,9834,10153,10771],0); -ELEMENTS[49349] = Fluid3D([17656,17848,17924,17779],0); -ELEMENTS[49350] = Fluid3D([16100,15672,15341,15530],0); -ELEMENTS[49351] = Fluid3D([3551,3793,4069,3802],0); -ELEMENTS[49352] = Fluid3D([8552,9083,9532,9464],0); -ELEMENTS[49353] = Fluid3D([5381,5658,5183,5089],0); -ELEMENTS[49354] = Fluid3D([18399,18368,18212,18401],0); -ELEMENTS[49355] = Fluid3D([3237,2872,2827,3081],0); -ELEMENTS[49356] = Fluid3D([2827,3237,3081,3133],0); -ELEMENTS[49357] = Fluid3D([2827,3237,3133,3042],0); -ELEMENTS[49358] = Fluid3D([3237,3133,3042,3147],0); -ELEMENTS[49359] = Fluid3D([3133,3042,3147,2762],0); -ELEMENTS[49360] = Fluid3D([3133,2827,3042,2762],0); -ELEMENTS[49361] = Fluid3D([2827,3042,2762,3113],0); -ELEMENTS[49362] = Fluid3D([3042,2762,3113,3147],0); -ELEMENTS[49363] = Fluid3D([3113,3042,3147,3237],0); -ELEMENTS[49364] = Fluid3D([3113,3042,3237,2827],0); -ELEMENTS[49365] = Fluid3D([9974,10632,11300,10586],0); -ELEMENTS[49366] = Fluid3D([6626,6006,6395,6494],0); -ELEMENTS[49367] = Fluid3D([17783,17576,17463,17742],0); -ELEMENTS[49368] = Fluid3D([10037,10886,10621,9618],0); -ELEMENTS[49369] = Fluid3D([11641,11242,11901,10829],0); -ELEMENTS[49370] = Fluid3D([7381,7659,7309,8276],0); -ELEMENTS[49371] = Fluid3D([8917,8369,8417,7968],0); -ELEMENTS[49372] = Fluid3D([8917,8369,7968,8606],0); -ELEMENTS[49373] = Fluid3D([4487,4208,4825,4886],0); -ELEMENTS[49374] = Fluid3D([16410,16454,16275,15655],0); -ELEMENTS[49375] = Fluid3D([16496,16136,16213,15749],0); -ELEMENTS[49376] = Fluid3D([4324,4219,4091,3842],0); -ELEMENTS[49377] = Fluid3D([4324,4219,3842,4467],0); -ELEMENTS[49378] = Fluid3D([4219,4091,3842,3839],0); -ELEMENTS[49379] = Fluid3D([3842,4219,3839,4467],0); -ELEMENTS[49380] = Fluid3D([12808,12199,12280,13098],0); -ELEMENTS[49381] = Fluid3D([8057,8659,7895,9080],0); -ELEMENTS[49382] = Fluid3D([15180,15334,15666,15967],0); -ELEMENTS[49383] = Fluid3D([14448,14915,15031,15141],0); -ELEMENTS[49384] = Fluid3D([10377,10260,11115,10215],0); -ELEMENTS[49385] = Fluid3D([12120,11777,12964,12038],0); -ELEMENTS[49386] = Fluid3D([17021,17003,16649,17165],0); -ELEMENTS[49387] = Fluid3D([16649,17021,17165,16864],0); -ELEMENTS[49388] = Fluid3D([16649,17021,16864,16422],0); -ELEMENTS[49389] = Fluid3D([7312,7827,7223,8103],0); -ELEMENTS[49390] = Fluid3D([10553,11448,9956,10552],0); -ELEMENTS[49391] = Fluid3D([7005,7180,7618,8217],0); -ELEMENTS[49392] = Fluid3D([9376,9116,9507,10122],0); -ELEMENTS[49393] = Fluid3D([12124,12299,12901,12887],0); -ELEMENTS[49394] = Fluid3D([15884,15648,16188,15509],0); -ELEMENTS[49395] = Fluid3D([15495,15891,15419,15226],0); -ELEMENTS[49396] = Fluid3D([3076,3226,2838,3210],0); -ELEMENTS[49397] = Fluid3D([18310,18239,18421,18378],0); -ELEMENTS[49398] = Fluid3D([15524,15868,15588,15076],0); -ELEMENTS[49399] = Fluid3D([16418,16842,16873,16214],0); -ELEMENTS[49400] = Fluid3D([3381,3519,3808,3382],0); -ELEMENTS[49401] = Fluid3D([3381,3519,3382,3112],0); -ELEMENTS[49402] = Fluid3D([3519,3808,3382,3369],0); -ELEMENTS[49403] = Fluid3D([3519,3382,3112,3369],0); -ELEMENTS[49404] = Fluid3D([3382,3112,3369,3095],0); -ELEMENTS[49405] = Fluid3D([3369,3382,3095,3351],0); -ELEMENTS[49406] = Fluid3D([3382,3095,3351,3118],0); -ELEMENTS[49407] = Fluid3D([3369,3382,3351,3783],0); -ELEMENTS[49408] = Fluid3D([3382,3095,3118,3381],0); -ELEMENTS[49409] = Fluid3D([3095,3351,3118,2817],0); -ELEMENTS[49410] = Fluid3D([3382,3112,3095,3381],0); -ELEMENTS[49411] = Fluid3D([3351,3382,3118,3783],0); -ELEMENTS[49412] = Fluid3D([3095,3369,3351,2964],0); -ELEMENTS[49413] = Fluid3D([17523,17688,17852,17803],0); -ELEMENTS[49414] = Fluid3D([11196,10440,10199,11120],0); -ELEMENTS[49415] = Fluid3D([18529,18480,18599,18603],0); -ELEMENTS[49416] = Fluid3D([14168,13960,13336,13527],0); -ELEMENTS[49417] = Fluid3D([9901,9053,9259,8764],0); -ELEMENTS[49418] = Fluid3D([9053,9259,8764,8655],0); -ELEMENTS[49419] = Fluid3D([12811,13660,13526,12627],0); -ELEMENTS[49420] = Fluid3D([16533,16364,16408,16799],0); -ELEMENTS[49421] = Fluid3D([18044,17974,18088,18277],0); -ELEMENTS[49422] = Fluid3D([11505,11172,12048,11658],0); -ELEMENTS[49423] = Fluid3D([11172,12048,11658,11184],0); -ELEMENTS[49424] = Fluid3D([7278,7460,7141,7750],0); -ELEMENTS[49425] = Fluid3D([7278,7460,7750,8415],0); -ELEMENTS[49426] = Fluid3D([7750,7278,8415,8302],0); -ELEMENTS[49427] = Fluid3D([13903,14516,14012,13366],0); -ELEMENTS[49428] = Fluid3D([5063,4525,4583,4996],0); -ELEMENTS[49429] = Fluid3D([5406,5010,5475,5545],0); -ELEMENTS[49430] = Fluid3D([2187,2383,2453,2235],0); -ELEMENTS[49431] = Fluid3D([5192,5250,5494,5738],0); -ELEMENTS[49432] = Fluid3D([5192,5250,5738,5358],0); -ELEMENTS[49433] = Fluid3D([12103,12618,13155,12870],0); -ELEMENTS[49434] = Fluid3D([12618,13155,12870,13537],0); -ELEMENTS[49435] = Fluid3D([13155,12870,13537,14034],0); -ELEMENTS[49436] = Fluid3D([10502,10336,10784,10277],0); -ELEMENTS[49437] = Fluid3D([10336,10784,10277,11509],0); -ELEMENTS[49438] = Fluid3D([10784,10277,11509,10456],0); -ELEMENTS[49439] = Fluid3D([10784,10277,10456,10502],0); -ELEMENTS[49440] = Fluid3D([16567,16287,16756,16377],0); -ELEMENTS[49441] = Fluid3D([11896,12758,12023,11781],0); -ELEMENTS[49442] = Fluid3D([12023,11896,11781,11004],0); -ELEMENTS[49443] = Fluid3D([11896,12758,11781,12669],0); -ELEMENTS[49444] = Fluid3D([11896,11781,11004,10727],0); -ELEMENTS[49445] = Fluid3D([18007,18224,18212,18102],0); -ELEMENTS[49446] = Fluid3D([9327,8533,8731,8325],0); -ELEMENTS[49447] = Fluid3D([14030,13060,13401,13822],0); -ELEMENTS[49448] = Fluid3D([4783,4253,4222,4460],0); -ELEMENTS[49449] = Fluid3D([4253,4222,4460,3815],0); -ELEMENTS[49450] = Fluid3D([5090,4864,5225,4889],0); -ELEMENTS[49451] = Fluid3D([4864,5225,4889,4603],0); -ELEMENTS[49452] = Fluid3D([4864,5225,4603,5077],0); -ELEMENTS[49453] = Fluid3D([12288,12011,12366,13136],0); -ELEMENTS[49454] = Fluid3D([11136,11205,11833,11555],0); -ELEMENTS[49455] = Fluid3D([11833,11136,11555,11430],0); -ELEMENTS[49456] = Fluid3D([11555,11833,11430,12433],0); -ELEMENTS[49457] = Fluid3D([11555,11833,12433,12072],0); -ELEMENTS[49458] = Fluid3D([11833,11430,12433,11136],0); -ELEMENTS[49459] = Fluid3D([11430,11555,12433,11050],0); -ELEMENTS[49460] = Fluid3D([11430,11555,11050,11136],0); -ELEMENTS[49461] = Fluid3D([11430,11050,11676,10435],0); -ELEMENTS[49462] = Fluid3D([12433,11430,11676,11558],0); -ELEMENTS[49463] = Fluid3D([11430,11676,11558,10435],0); -ELEMENTS[49464] = Fluid3D([12433,11430,11558,11136],0); -ELEMENTS[49465] = Fluid3D([11430,11558,11136,10433],0); -ELEMENTS[49466] = Fluid3D([11555,11833,12072,11205],0); -ELEMENTS[49467] = Fluid3D([11430,11558,10433,10435],0); -ELEMENTS[49468] = Fluid3D([14459,13835,13916,13952],0); -ELEMENTS[49469] = Fluid3D([5671,5207,5845,5902],0); -ELEMENTS[49470] = Fluid3D([16659,16217,16672,16433],0); -ELEMENTS[49471] = Fluid3D([8160,7760,8360,7427],0); -ELEMENTS[49472] = Fluid3D([10883,11173,11236,12152],0); -ELEMENTS[49473] = Fluid3D([13014,12683,12995,11861],0); -ELEMENTS[49474] = Fluid3D([3631,3666,4071,3673],0); -ELEMENTS[49475] = Fluid3D([3201,2949,3172,3473],0); -ELEMENTS[49476] = Fluid3D([17503,17686,17893,17784],0); -ELEMENTS[49477] = Fluid3D([17503,17686,17784,17461],0); -ELEMENTS[49478] = Fluid3D([17503,17686,17461,17131],0); -ELEMENTS[49479] = Fluid3D([17686,17784,17461,17941],0); -ELEMENTS[49480] = Fluid3D([17784,17503,17461,17384],0); -ELEMENTS[49481] = Fluid3D([17503,17461,17384,17131],0); -ELEMENTS[49482] = Fluid3D([17461,17784,17384,17681],0); -ELEMENTS[49483] = Fluid3D([17461,17384,17131,17198],0); -ELEMENTS[49484] = Fluid3D([17131,17461,17198,17519],0); -ELEMENTS[49485] = Fluid3D([17686,17784,17941,17893],0); -ELEMENTS[49486] = Fluid3D([9143,8745,8919,9962],0); -ELEMENTS[49487] = Fluid3D([6763,6934,7315,6212],0); -ELEMENTS[49488] = Fluid3D([9566,10199,9472,9940],0); -ELEMENTS[49489] = Fluid3D([10199,9472,9940,10893],0); -ELEMENTS[49490] = Fluid3D([13551,14053,14065,14310],0); -ELEMENTS[49491] = Fluid3D([18528,18444,18414,18495],0); -ELEMENTS[49492] = Fluid3D([18528,18444,18495,18493],0); -ELEMENTS[49493] = Fluid3D([18495,18528,18493,18587],0); -ELEMENTS[49494] = Fluid3D([18495,18528,18587,18504],0); -ELEMENTS[49495] = Fluid3D([18495,18528,18504,18414],0); -ELEMENTS[49496] = Fluid3D([18504,18495,18414,18354],0); -ELEMENTS[49497] = Fluid3D([18493,18495,18587,18616],0); -ELEMENTS[49498] = Fluid3D([18587,18495,18504,18570],0); -ELEMENTS[49499] = Fluid3D([18495,18504,18570,18354],0); -ELEMENTS[49500] = Fluid3D([18528,18493,18587,18620],0); -ELEMENTS[49501] = Fluid3D([18587,18528,18620,18504],0); -ELEMENTS[49502] = Fluid3D([18587,18495,18570,18616],0); -ELEMENTS[49503] = Fluid3D([18570,18587,18616,18634],0); -ELEMENTS[49504] = Fluid3D([18587,18616,18634,18660],0); -ELEMENTS[49505] = Fluid3D([18570,18587,18634,18607],0); -ELEMENTS[49506] = Fluid3D([18587,18634,18607,18620],0); -ELEMENTS[49507] = Fluid3D([18634,18607,18620,18654],0); -ELEMENTS[49508] = Fluid3D([18587,18634,18620,18660],0); -ELEMENTS[49509] = Fluid3D([18607,18587,18620,18504],0); -ELEMENTS[49510] = Fluid3D([18634,18607,18654,18604],0); -ELEMENTS[49511] = Fluid3D([18634,18607,18604,18570],0); -ELEMENTS[49512] = Fluid3D([18607,18654,18604,18571],0); -ELEMENTS[49513] = Fluid3D([18604,18607,18571,18504],0); -ELEMENTS[49514] = Fluid3D([18604,18607,18504,18570],0); -ELEMENTS[49515] = Fluid3D([18607,18620,18654,18571],0); -ELEMENTS[49516] = Fluid3D([18607,18571,18504,18620],0); -ELEMENTS[49517] = Fluid3D([18634,18620,18660,18673],0); -ELEMENTS[49518] = Fluid3D([18634,18620,18673,18654],0); -ELEMENTS[49519] = Fluid3D([18587,18616,18660,18574],0); -ELEMENTS[49520] = Fluid3D([13870,12918,13036,13773],0); -ELEMENTS[49521] = Fluid3D([12918,13036,13773,12944],0); -ELEMENTS[49522] = Fluid3D([12918,13036,12944,11997],0); -ELEMENTS[49523] = Fluid3D([13036,13773,12944,12767],0); -ELEMENTS[49524] = Fluid3D([13773,12918,12944,13444],0); -ELEMENTS[49525] = Fluid3D([12918,12944,13444,12494],0); -ELEMENTS[49526] = Fluid3D([12918,12944,12494,11932],0); -ELEMENTS[49527] = Fluid3D([12944,13444,12494,12840],0); -ELEMENTS[49528] = Fluid3D([12494,12944,12840,11932],0); -ELEMENTS[49529] = Fluid3D([12944,13773,13444,13959],0); -ELEMENTS[49530] = Fluid3D([12944,13444,12840,13959],0); -ELEMENTS[49531] = Fluid3D([13444,12918,12494,12750],0); -ELEMENTS[49532] = Fluid3D([12494,13444,12750,12928],0); -ELEMENTS[49533] = Fluid3D([13444,12494,12840,12928],0); -ELEMENTS[49534] = Fluid3D([12918,12494,12750,11923],0); -ELEMENTS[49535] = Fluid3D([12494,12750,11923,11601],0); -ELEMENTS[49536] = Fluid3D([12944,13036,12767,11997],0); -ELEMENTS[49537] = Fluid3D([12494,12840,12928,11601],0); -ELEMENTS[49538] = Fluid3D([12750,12494,12928,11601],0); -ELEMENTS[49539] = Fluid3D([12326,13109,11832,12673],0); -ELEMENTS[49540] = Fluid3D([16713,16431,16967,16650],0); -ELEMENTS[49541] = Fluid3D([16738,16283,16173,16434],0); -ELEMENTS[49542] = Fluid3D([2614,2750,2438,2385],0); -ELEMENTS[49543] = Fluid3D([12087,11275,11588,11272],0); -ELEMENTS[49544] = Fluid3D([1966,1807,1972,1959],0); -ELEMENTS[49545] = Fluid3D([3062,2913,2840,3381],0); -ELEMENTS[49546] = Fluid3D([7273,7848,7806,8176],0); -ELEMENTS[49547] = Fluid3D([7273,7848,8176,7664],0); -ELEMENTS[49548] = Fluid3D([7806,7273,8176,7133],0); -ELEMENTS[49549] = Fluid3D([13661,14305,13462,14143],0); -ELEMENTS[49550] = Fluid3D([16013,16315,16619,16704],0); -ELEMENTS[49551] = Fluid3D([10007,9213,10239,10263],0); -ELEMENTS[49552] = Fluid3D([3226,2965,2838,3160],0); -ELEMENTS[49553] = Fluid3D([3226,2965,3160,3310],0); -ELEMENTS[49554] = Fluid3D([2838,3226,3160,3210],0); -ELEMENTS[49555] = Fluid3D([3160,3226,3310,3557],0); -ELEMENTS[49556] = Fluid3D([17824,17469,17743,17602],0); -ELEMENTS[49557] = Fluid3D([17592,17719,17933,17701],0); -ELEMENTS[49558] = Fluid3D([8598,7775,8610,8367],0); -ELEMENTS[49559] = Fluid3D([4726,4859,5299,5220],0); -ELEMENTS[49560] = Fluid3D([15865,15576,15674,14974],0); -ELEMENTS[49561] = Fluid3D([15741,16117,16144,15554],0); -ELEMENTS[49562] = Fluid3D([11755,11552,11046,10773],0); -ELEMENTS[49563] = Fluid3D([4993,5352,5316,5615],0); -ELEMENTS[49564] = Fluid3D([12335,11512,12478,11965],0); -ELEMENTS[49565] = Fluid3D([12335,11512,11965,11741],0); -ELEMENTS[49566] = Fluid3D([4663,4377,5028,5081],0); -ELEMENTS[49567] = Fluid3D([10035,9215,9587,9129],0); -ELEMENTS[49568] = Fluid3D([12990,12569,13632,13673],0); -ELEMENTS[49569] = Fluid3D([14477,13953,13716,14157],0); -ELEMENTS[49570] = Fluid3D([13722,14048,14431,13529],0); -ELEMENTS[49571] = Fluid3D([13722,14048,13529,12837],0); -ELEMENTS[49572] = Fluid3D([9005,8906,9233,10139],0); -ELEMENTS[49573] = Fluid3D([15410,15569,16029,15881],0); -ELEMENTS[49574] = Fluid3D([8376,9042,8015,8835],0); -ELEMENTS[49575] = Fluid3D([15718,15965,16266,16439],0); -ELEMENTS[49576] = Fluid3D([7717,8727,8048,7733],0); -ELEMENTS[49577] = Fluid3D([14706,15137,15442,14648],0); -ELEMENTS[49578] = Fluid3D([9181,9686,9555,10192],0); -ELEMENTS[49579] = Fluid3D([2835,2911,3037,2735],0); -ELEMENTS[49580] = Fluid3D([2835,2911,2735,2451],0); -ELEMENTS[49581] = Fluid3D([4567,4839,4159,4506],0); -ELEMENTS[49582] = Fluid3D([15486,16008,15992,15502],0); -ELEMENTS[49583] = Fluid3D([11729,10830,11671,11450],0); -ELEMENTS[49584] = Fluid3D([7892,7495,8330,8104],0); -ELEMENTS[49585] = Fluid3D([16863,17249,17312,16860],0); -ELEMENTS[49586] = Fluid3D([17312,16863,16860,16894],0); -ELEMENTS[49587] = Fluid3D([16863,17249,16860,17031],0); -ELEMENTS[49588] = Fluid3D([16860,16863,17031,16445],0); -ELEMENTS[49589] = Fluid3D([16860,16863,16445,16280],0); -ELEMENTS[49590] = Fluid3D([6476,6719,7392,6879],0); -ELEMENTS[49591] = Fluid3D([6803,6800,5984,6627],0); -ELEMENTS[49592] = Fluid3D([3649,3292,3360,3090],0); -ELEMENTS[49593] = Fluid3D([13705,12848,13079,12803],0); -ELEMENTS[49594] = Fluid3D([16978,17068,17097,16580],0); -ELEMENTS[49595] = Fluid3D([11998,11709,10703,11016],0); -ELEMENTS[49596] = Fluid3D([7270,7809,8074,7938],0); -ELEMENTS[49597] = Fluid3D([7270,7809,7938,7599],0); -ELEMENTS[49598] = Fluid3D([7809,8074,7938,8814],0); -ELEMENTS[49599] = Fluid3D([8074,7270,7938,7823],0); -ELEMENTS[49600] = Fluid3D([7938,7270,7599,7130],0); -ELEMENTS[49601] = Fluid3D([7938,7270,7130,7823],0); -ELEMENTS[49602] = Fluid3D([7270,7130,7823,7074],0); -ELEMENTS[49603] = Fluid3D([7270,7130,7074,6407],0); -ELEMENTS[49604] = Fluid3D([7074,7270,6407,7263],0); -ELEMENTS[49605] = Fluid3D([7074,7270,7263,8074],0); -ELEMENTS[49606] = Fluid3D([7270,7130,6407,6940],0); -ELEMENTS[49607] = Fluid3D([7270,7130,6940,7599],0); -ELEMENTS[49608] = Fluid3D([6940,7270,7599,7026],0); -ELEMENTS[49609] = Fluid3D([7130,6940,7599,6472],0); -ELEMENTS[49610] = Fluid3D([7130,6940,6472,6407],0); -ELEMENTS[49611] = Fluid3D([6940,6472,6407,6707],0); -ELEMENTS[49612] = Fluid3D([6940,6472,6707,7599],0); -ELEMENTS[49613] = Fluid3D([6707,6940,7599,7026],0); -ELEMENTS[49614] = Fluid3D([6407,7270,6940,6433],0); -ELEMENTS[49615] = Fluid3D([6940,6407,6433,6707],0); -ELEMENTS[49616] = Fluid3D([6433,6940,6707,7026],0); -ELEMENTS[49617] = Fluid3D([6433,6940,7026,7270],0); -ELEMENTS[49618] = Fluid3D([7823,7270,7074,8074],0); -ELEMENTS[49619] = Fluid3D([7809,7938,7599,8336],0); -ELEMENTS[49620] = Fluid3D([12582,11722,12256,11566],0); -ELEMENTS[49621] = Fluid3D([13855,13971,13179,13521],0); -ELEMENTS[49622] = Fluid3D([13971,13179,13521,13205],0); -ELEMENTS[49623] = Fluid3D([13855,13971,13521,14322],0); -ELEMENTS[49624] = Fluid3D([14391,14953,15402,15396],0); -ELEMENTS[49625] = Fluid3D([15276,15271,15335,14676],0); -ELEMENTS[49626] = Fluid3D([11060,10207,11359,11103],0); -ELEMENTS[49627] = Fluid3D([7967,8584,8822,8841],0); -ELEMENTS[49628] = Fluid3D([5627,5567,6103,6204],0); -ELEMENTS[49629] = Fluid3D([5992,5315,5742,6112],0); -ELEMENTS[49630] = Fluid3D([11172,10192,11406,10994],0); -ELEMENTS[49631] = Fluid3D([12036,11434,12646,12214],0); -ELEMENTS[49632] = Fluid3D([15326,15548,15728,16121],0); -ELEMENTS[49633] = Fluid3D([17019,17304,16934,16723],0); -ELEMENTS[49634] = Fluid3D([12804,13653,13058,12629],0); -ELEMENTS[49635] = Fluid3D([7868,8176,7133,7608],0); -ELEMENTS[49636] = Fluid3D([4361,4806,4662,5206],0); -ELEMENTS[49637] = Fluid3D([8841,9583,8584,8822],0); -ELEMENTS[49638] = Fluid3D([12024,12299,11394,11812],0); -ELEMENTS[49639] = Fluid3D([16610,16309,16277,16645],0); -ELEMENTS[49640] = Fluid3D([16277,16610,16645,16559],0); -ELEMENTS[49641] = Fluid3D([16645,16277,16559,16550],0); -ELEMENTS[49642] = Fluid3D([16559,16645,16550,16884],0); -ELEMENTS[49643] = Fluid3D([16550,16559,16884,16813],0); -ELEMENTS[49644] = Fluid3D([16559,16645,16884,16610],0); -ELEMENTS[49645] = Fluid3D([16884,16559,16610,16637],0); -ELEMENTS[49646] = Fluid3D([16277,16559,16550,16133],0); -ELEMENTS[49647] = Fluid3D([16645,16277,16550,16296],0); -ELEMENTS[49648] = Fluid3D([16645,16277,16296,16387],0); -ELEMENTS[49649] = Fluid3D([16645,16277,16387,16736],0); -ELEMENTS[49650] = Fluid3D([16610,16884,16637,17196],0); -ELEMENTS[49651] = Fluid3D([16309,16277,16645,16736],0); -ELEMENTS[49652] = Fluid3D([16559,16610,16637,16209],0); -ELEMENTS[49653] = Fluid3D([16637,16559,16209,16133],0); -ELEMENTS[49654] = Fluid3D([16610,16637,16209,16625],0); -ELEMENTS[49655] = Fluid3D([16637,16209,16625,16427],0); -ELEMENTS[49656] = Fluid3D([16625,16637,16427,16812],0); -ELEMENTS[49657] = Fluid3D([16625,16637,16812,17115],0); -ELEMENTS[49658] = Fluid3D([16610,16637,16625,17196],0); -ELEMENTS[49659] = Fluid3D([16559,16209,16133,16277],0); -ELEMENTS[49660] = Fluid3D([16559,16209,16277,16610],0); -ELEMENTS[49661] = Fluid3D([16645,16884,16610,16974],0); -ELEMENTS[49662] = Fluid3D([16884,16610,16974,17196],0); -ELEMENTS[49663] = Fluid3D([16610,16645,16974,16736],0); -ELEMENTS[49664] = Fluid3D([16610,16974,17196,16519],0); -ELEMENTS[49665] = Fluid3D([16974,16610,16736,16309],0); -ELEMENTS[49666] = Fluid3D([3613,3675,3647,3437],0); -ELEMENTS[49667] = Fluid3D([3613,3675,3437,3362],0); -ELEMENTS[49668] = Fluid3D([6541,7096,6351,6330],0); -ELEMENTS[49669] = Fluid3D([7096,6351,6330,6097],0); -ELEMENTS[49670] = Fluid3D([6351,6541,6330,5748],0); -ELEMENTS[49671] = Fluid3D([11815,10903,10921,10429],0); -ELEMENTS[49672] = Fluid3D([8675,8869,9411,10020],0); -ELEMENTS[49673] = Fluid3D([3805,3469,3890,3797],0); -ELEMENTS[49674] = Fluid3D([9022,8764,9149,8044],0); -ELEMENTS[49675] = Fluid3D([18277,18250,18088,18044],0); -ELEMENTS[49676] = Fluid3D([18250,18088,18044,18081],0); -ELEMENTS[49677] = Fluid3D([13816,13207,13272,12801],0); -ELEMENTS[49678] = Fluid3D([14255,14058,14159,14868],0); -ELEMENTS[49679] = Fluid3D([13802,13148,13559,13197],0); -ELEMENTS[49680] = Fluid3D([13802,13148,13197,13438],0); -ELEMENTS[49681] = Fluid3D([13802,13148,13438,14056],0); -ELEMENTS[49682] = Fluid3D([15301,15613,14797,14931],0); -ELEMENTS[49683] = Fluid3D([13415,14061,13445,13596],0); -ELEMENTS[49684] = Fluid3D([14864,14229,14380,15059],0); -ELEMENTS[49685] = Fluid3D([2379,2343,2419,2062],0); -ELEMENTS[49686] = Fluid3D([10361,11148,11070,11079],0); -ELEMENTS[49687] = Fluid3D([11948,11654,12840,11932],0); -ELEMENTS[49688] = Fluid3D([11948,11654,11932,10851],0); -ELEMENTS[49689] = Fluid3D([4924,4539,5046,4715],0); -ELEMENTS[49690] = Fluid3D([4924,4539,4715,4812],0); -ELEMENTS[49691] = Fluid3D([4924,4539,4812,4229],0); -ELEMENTS[49692] = Fluid3D([4539,4715,4812,4229],0); -ELEMENTS[49693] = Fluid3D([12055,11712,12128,11918],0); -ELEMENTS[49694] = Fluid3D([8478,8089,8794,7849],0); -ELEMENTS[49695] = Fluid3D([17074,17360,17154,17271],0); -ELEMENTS[49696] = Fluid3D([5193,5549,5123,5665],0); -ELEMENTS[49697] = Fluid3D([10517,10044,9884,10497],0); -ELEMENTS[49698] = Fluid3D([3088,3190,2956,3260],0); -ELEMENTS[49699] = Fluid3D([7894,7632,7378,7274],0); -ELEMENTS[49700] = Fluid3D([7378,7894,7274,7153],0); -ELEMENTS[49701] = Fluid3D([14286,14799,14855,14835],0); -ELEMENTS[49702] = Fluid3D([14286,14799,14835,14255],0); -ELEMENTS[49703] = Fluid3D([14286,14799,14255,14507],0); -ELEMENTS[49704] = Fluid3D([18578,18551,18583,18644],0); -ELEMENTS[49705] = Fluid3D([11479,10452,11538,11628],0); -ELEMENTS[49706] = Fluid3D([14390,14882,14032,14685],0); -ELEMENTS[49707] = Fluid3D([17940,17950,18218,18150],0); -ELEMENTS[49708] = Fluid3D([18218,17940,18150,18325],0); -ELEMENTS[49709] = Fluid3D([13549,13405,14239,14057],0); -ELEMENTS[49710] = Fluid3D([13608,14312,14131,13877],0); -ELEMENTS[49711] = Fluid3D([6707,6186,5930,6472],0); -ELEMENTS[49712] = Fluid3D([6186,5930,6472,5861],0); -ELEMENTS[49713] = Fluid3D([6186,5930,5861,5356],0); -ELEMENTS[49714] = Fluid3D([6186,5930,5356,5775],0); -ELEMENTS[49715] = Fluid3D([6472,6186,5861,6407],0); -ELEMENTS[49716] = Fluid3D([7733,7411,7661,6479],0); -ELEMENTS[49717] = Fluid3D([11442,11813,11133,12010],0); -ELEMENTS[49718] = Fluid3D([10094,9472,10345,10893],0); -ELEMENTS[49719] = Fluid3D([10358,10057,10181,9697],0); -ELEMENTS[49720] = Fluid3D([10358,10057,9697,9876],0); -ELEMENTS[49721] = Fluid3D([9697,10358,9876,9919],0); -ELEMENTS[49722] = Fluid3D([10358,10057,9876,10818],0); -ELEMENTS[49723] = Fluid3D([9876,10358,10818,9919],0); -ELEMENTS[49724] = Fluid3D([10181,10358,9697,10447],0); -ELEMENTS[49725] = Fluid3D([14241,14287,14711,14381],0); -ELEMENTS[49726] = Fluid3D([5068,4478,4920,4985],0); -ELEMENTS[49727] = Fluid3D([14982,15684,15801,15706],0); -ELEMENTS[49728] = Fluid3D([16109,15693,15486,15665],0); -ELEMENTS[49729] = Fluid3D([16109,15693,15665,15831],0); -ELEMENTS[49730] = Fluid3D([15665,16109,15831,15677],0); -ELEMENTS[49731] = Fluid3D([15486,16109,15665,15677],0); -ELEMENTS[49732] = Fluid3D([15831,15665,15677,15020],0); -ELEMENTS[49733] = Fluid3D([15831,15665,15020,15281],0); -ELEMENTS[49734] = Fluid3D([15831,15665,15281,15693],0); -ELEMENTS[49735] = Fluid3D([15665,15281,15693,14832],0); -ELEMENTS[49736] = Fluid3D([5390,5216,4657,5008],0); -ELEMENTS[49737] = Fluid3D([5390,5216,5008,5594],0); -ELEMENTS[49738] = Fluid3D([5008,5390,5594,5857],0); -ELEMENTS[49739] = Fluid3D([5390,5216,5594,5823],0); -ELEMENTS[49740] = Fluid3D([4657,5390,5008,4845],0); -ELEMENTS[49741] = Fluid3D([14515,14126,13547,14358],0); -ELEMENTS[49742] = Fluid3D([15879,15263,15297,15565],0); -ELEMENTS[49743] = Fluid3D([7410,6979,7185,7889],0); -ELEMENTS[49744] = Fluid3D([2616,2866,2627,2558],0); -ELEMENTS[49745] = Fluid3D([3988,4182,4557,4601],0); -ELEMENTS[49746] = Fluid3D([4182,4557,4601,4765],0); -ELEMENTS[49747] = Fluid3D([10849,11143,11660,11644],0); -ELEMENTS[49748] = Fluid3D([16607,16961,16652,16402],0); -ELEMENTS[49749] = Fluid3D([16652,16607,16402,15843],0); -ELEMENTS[49750] = Fluid3D([16607,16961,16402,16811],0); -ELEMENTS[49751] = Fluid3D([16402,16607,16811,16248],0); -ELEMENTS[49752] = Fluid3D([16402,16607,16248,15746],0); -ELEMENTS[49753] = Fluid3D([8294,8656,9035,9488],0); -ELEMENTS[49754] = Fluid3D([12076,12908,12707,11946],0); -ELEMENTS[49755] = Fluid3D([6559,6810,6337,5885],0); -ELEMENTS[49756] = Fluid3D([10149,10068,9637,10712],0); -ELEMENTS[49757] = Fluid3D([9414,9384,10110,8962],0); -ELEMENTS[49758] = Fluid3D([8474,8034,8266,7468],0); -ELEMENTS[49759] = Fluid3D([3156,3203,2963,3187],0); -ELEMENTS[49760] = Fluid3D([2963,3156,3187,2859],0); -ELEMENTS[49761] = Fluid3D([3203,2963,3187,3485],0); -ELEMENTS[49762] = Fluid3D([2963,3187,3485,3222],0); -ELEMENTS[49763] = Fluid3D([17028,17285,17222,17219],0); -ELEMENTS[49764] = Fluid3D([17285,17222,17219,17554],0); -ELEMENTS[49765] = Fluid3D([17285,17222,17554,17375],0); -ELEMENTS[49766] = Fluid3D([17699,17547,17485,17702],0); -ELEMENTS[49767] = Fluid3D([17547,17485,17702,17756],0); -ELEMENTS[49768] = Fluid3D([17699,17547,17702,17778],0); -ELEMENTS[49769] = Fluid3D([17547,17702,17778,17918],0); -ELEMENTS[49770] = Fluid3D([17778,17918,17954,17718],0); -ELEMENTS[49771] = Fluid3D([17954,17778,17718,17762],0); -ELEMENTS[49772] = Fluid3D([17778,17918,17718,17550],0); -ELEMENTS[49773] = Fluid3D([17778,17718,17762,17516],0); -ELEMENTS[49774] = Fluid3D([17699,17547,17778,17718],0); -ELEMENTS[49775] = Fluid3D([17547,17778,17718,17550],0); -ELEMENTS[49776] = Fluid3D([17702,17699,17778,17954],0); -ELEMENTS[49777] = Fluid3D([17918,17778,17954,17702],0); -ELEMENTS[49778] = Fluid3D([17699,17778,17954,17672],0); -ELEMENTS[49779] = Fluid3D([17778,17954,17672,17762],0); -ELEMENTS[49780] = Fluid3D([17672,17778,17762,17516],0); -ELEMENTS[49781] = Fluid3D([17954,17672,17762,17396],0); -ELEMENTS[49782] = Fluid3D([17672,17762,17396,17516],0); -ELEMENTS[49783] = Fluid3D([17699,17778,17672,17516],0); -ELEMENTS[49784] = Fluid3D([17954,17672,17396,17699],0); -ELEMENTS[49785] = Fluid3D([17672,17396,17699,17516],0); -ELEMENTS[49786] = Fluid3D([12129,11918,12745,12027],0); -ELEMENTS[49787] = Fluid3D([17760,17916,17861,18073],0); -ELEMENTS[49788] = Fluid3D([17760,17916,18073,18126],0); -ELEMENTS[49789] = Fluid3D([6264,6862,6868,6984],0); -ELEMENTS[49790] = Fluid3D([7604,7893,7231,7478],0); -ELEMENTS[49791] = Fluid3D([11543,11339,11716,10775],0); -ELEMENTS[49792] = Fluid3D([11543,11339,10775,10520],0); -ELEMENTS[49793] = Fluid3D([8623,8758,9295,9812],0); -ELEMENTS[49794] = Fluid3D([16789,16433,16659,16672],0); -ELEMENTS[49795] = Fluid3D([16735,16273,16150,16814],0); -ELEMENTS[49796] = Fluid3D([9936,9675,8653,9444],0); -ELEMENTS[49797] = Fluid3D([5995,6184,5847,6278],0); -ELEMENTS[49798] = Fluid3D([4155,4399,4657,4472],0); -ELEMENTS[49799] = Fluid3D([4155,4399,4472,3993],0); -ELEMENTS[49800] = Fluid3D([4155,4399,3993,3713],0); -ELEMENTS[49801] = Fluid3D([14815,15362,14882,15780],0); -ELEMENTS[49802] = Fluid3D([8994,9328,9999,8622],0); -ELEMENTS[49803] = Fluid3D([5391,5210,5132,4668],0); -ELEMENTS[49804] = Fluid3D([10918,10065,10003,10664],0); -ELEMENTS[49805] = Fluid3D([18377,18482,18560,18476],0); -ELEMENTS[49806] = Fluid3D([8462,7848,8704,8791],0); -ELEMENTS[49807] = Fluid3D([15805,15632,15396,14953],0); -ELEMENTS[49808] = Fluid3D([12918,12494,11923,11498],0); -ELEMENTS[49809] = Fluid3D([3084,3195,3152,2836],0); -ELEMENTS[49810] = Fluid3D([3084,3195,2836,2781],0); -ELEMENTS[49811] = Fluid3D([9091,8699,8575,7983],0); -ELEMENTS[49812] = Fluid3D([8495,8374,9180,8058],0); -ELEMENTS[49813] = Fluid3D([15093,15667,14882,15108],0); -ELEMENTS[49814] = Fluid3D([15093,15667,15108,15360],0); -ELEMENTS[49815] = Fluid3D([12484,13069,13612,13366],0); -ELEMENTS[49816] = Fluid3D([11844,11541,11903,10897],0); -ELEMENTS[49817] = Fluid3D([12887,11894,11671,12541],0); -ELEMENTS[49818] = Fluid3D([17951,17905,17631,17775],0); -ELEMENTS[49819] = Fluid3D([17905,17631,17775,18043],0); -ELEMENTS[49820] = Fluid3D([3116,3374,3600,3402],0); -ELEMENTS[49821] = Fluid3D([17743,17996,17839,17787],0); -ELEMENTS[49822] = Fluid3D([14698,14648,13988,14706],0); -ELEMENTS[49823] = Fluid3D([5793,6209,5598,6054],0); -ELEMENTS[49824] = Fluid3D([5793,6209,6054,6769],0); -ELEMENTS[49825] = Fluid3D([6430,6080,6817,6722],0); -ELEMENTS[49826] = Fluid3D([6919,7169,6517,6374],0); -ELEMENTS[49827] = Fluid3D([6919,7169,6374,6980],0); -ELEMENTS[49828] = Fluid3D([7169,6517,6374,6841],0); -ELEMENTS[49829] = Fluid3D([7169,6374,6980,6841],0); -ELEMENTS[49830] = Fluid3D([5855,5762,5910,6458],0); -ELEMENTS[49831] = Fluid3D([5192,5494,5979,5738],0); -ELEMENTS[49832] = Fluid3D([11305,12112,11150,11084],0); -ELEMENTS[49833] = Fluid3D([11150,11305,11084,10443],0); -ELEMENTS[49834] = Fluid3D([11150,11305,10443,10458],0); -ELEMENTS[49835] = Fluid3D([11084,11150,10443,10313],0); -ELEMENTS[49836] = Fluid3D([11150,10443,10313,10458],0); -ELEMENTS[49837] = Fluid3D([10443,10313,10458,9834],0); -ELEMENTS[49838] = Fluid3D([10458,10443,9834,10771],0); -ELEMENTS[49839] = Fluid3D([15434,15686,14987,15957],0); -ELEMENTS[49840] = Fluid3D([5514,5645,6100,6282],0); -ELEMENTS[49841] = Fluid3D([8124,7598,8485,7595],0); -ELEMENTS[49842] = Fluid3D([10564,10666,11571,11542],0); -ELEMENTS[49843] = Fluid3D([12874,12370,13452,12991],0); -ELEMENTS[49844] = Fluid3D([15566,16022,16349,15974],0); -ELEMENTS[49845] = Fluid3D([9257,9619,9501,10587],0); -ELEMENTS[49846] = Fluid3D([16690,16856,16701,17042],0); -ELEMENTS[49847] = Fluid3D([10245,11056,10937,11349],0); -ELEMENTS[49848] = Fluid3D([11704,11776,12384,12783],0); -ELEMENTS[49849] = Fluid3D([18165,18072,18290,18242],0); -ELEMENTS[49850] = Fluid3D([4641,5202,5215,5121],0); -ELEMENTS[49851] = Fluid3D([13345,13876,13046,14062],0); -ELEMENTS[49852] = Fluid3D([13345,13876,14062,13704],0); -ELEMENTS[49853] = Fluid3D([13046,13345,14062,13898],0); -ELEMENTS[49854] = Fluid3D([12948,12963,13601,14074],0); -ELEMENTS[49855] = Fluid3D([11448,11475,12041,12432],0); -ELEMENTS[49856] = Fluid3D([16512,16560,16178,16727],0); -ELEMENTS[49857] = Fluid3D([16582,16623,17007,16729],0); -ELEMENTS[49858] = Fluid3D([6233,6728,5744,5816],0); -ELEMENTS[49859] = Fluid3D([14601,14118,14502,15153],0); -ELEMENTS[49860] = Fluid3D([6608,7352,6417,6829],0); -ELEMENTS[49861] = Fluid3D([13310,13768,12939,12432],0); -ELEMENTS[49862] = Fluid3D([3609,3329,3482,3844],0); -ELEMENTS[49863] = Fluid3D([2741,2744,2618,2365],0); -ELEMENTS[49864] = Fluid3D([15497,14975,14980,15246],0); -ELEMENTS[49865] = Fluid3D([14980,15497,15246,15729],0); -ELEMENTS[49866] = Fluid3D([14980,15497,15729,15493],0); -ELEMENTS[49867] = Fluid3D([15497,15246,15729,15962],0); -ELEMENTS[49868] = Fluid3D([15497,15729,15493,15935],0); -ELEMENTS[49869] = Fluid3D([15497,15729,15935,16045],0); -ELEMENTS[49870] = Fluid3D([15497,15729,16045,15962],0); -ELEMENTS[49871] = Fluid3D([14128,14026,13311,13812],0); -ELEMENTS[49872] = Fluid3D([14026,13311,13812,13410],0); -ELEMENTS[49873] = Fluid3D([11388,11099,10829,11345],0); -ELEMENTS[49874] = Fluid3D([7854,7158,6987,8042],0); -ELEMENTS[49875] = Fluid3D([8956,8213,9237,9547],0); -ELEMENTS[49876] = Fluid3D([13851,14461,14514,14674],0); -ELEMENTS[49877] = Fluid3D([6333,6817,6976,6161],0); -ELEMENTS[49878] = Fluid3D([13602,12851,13343,13922],0); -ELEMENTS[49879] = Fluid3D([15971,16002,16379,16706],0); -ELEMENTS[49880] = Fluid3D([3374,2987,3410,3032],0); -ELEMENTS[49881] = Fluid3D([13070,12971,12142,12401],0); -ELEMENTS[49882] = Fluid3D([2752,3046,2637,2800],0); -ELEMENTS[49883] = Fluid3D([13928,14290,14855,14293],0); -ELEMENTS[49884] = Fluid3D([3586,3681,3307,3907],0); -ELEMENTS[49885] = Fluid3D([9457,9996,10836,9900],0); -ELEMENTS[49886] = Fluid3D([9457,9996,9900,8995],0); -ELEMENTS[49887] = Fluid3D([9457,9996,8995,9139],0); -ELEMENTS[49888] = Fluid3D([9900,9457,8995,9122],0); -ELEMENTS[49889] = Fluid3D([9457,8995,9122,8258],0); -ELEMENTS[49890] = Fluid3D([8995,9900,9122,9026],0); -ELEMENTS[49891] = Fluid3D([10875,11855,11045,11798],0); -ELEMENTS[49892] = Fluid3D([15772,15319,16121,15326],0); -ELEMENTS[49893] = Fluid3D([8933,9575,10000,9353],0); -ELEMENTS[49894] = Fluid3D([3719,3904,3565,3320],0); -ELEMENTS[49895] = Fluid3D([4016,3943,4488,3734],0); -ELEMENTS[49896] = Fluid3D([4016,3943,3734,3525],0); -ELEMENTS[49897] = Fluid3D([11911,12099,11726,12738],0); -ELEMENTS[49898] = Fluid3D([11911,12099,12738,12438],0); -ELEMENTS[49899] = Fluid3D([10660,10303,10258,9306],0); -ELEMENTS[49900] = Fluid3D([7663,8057,7771,7895],0); -ELEMENTS[49901] = Fluid3D([16683,16926,16972,16551],0); -ELEMENTS[49902] = Fluid3D([17063,17370,17272,17332],0); -ELEMENTS[49903] = Fluid3D([17063,17370,17332,17057],0); -ELEMENTS[49904] = Fluid3D([17332,17063,17057,17272],0); -ELEMENTS[49905] = Fluid3D([17370,17272,17332,17668],0); -ELEMENTS[49906] = Fluid3D([17332,17370,17668,17563],0); -ELEMENTS[49907] = Fluid3D([17668,17332,17563,17521],0); -ELEMENTS[49908] = Fluid3D([17332,17563,17521,17313],0); -ELEMENTS[49909] = Fluid3D([17668,17332,17521,17272],0); -ELEMENTS[49910] = Fluid3D([17563,17521,17313,17727],0); -ELEMENTS[49911] = Fluid3D([17563,17521,17727,17668],0); -ELEMENTS[49912] = Fluid3D([17521,17313,17727,17471],0); -ELEMENTS[49913] = Fluid3D([17727,17521,17471,17584],0); -ELEMENTS[49914] = Fluid3D([17727,17521,17584,17668],0); -ELEMENTS[49915] = Fluid3D([17521,17313,17471,16987],0); -ELEMENTS[49916] = Fluid3D([17521,17584,17668,17272],0); -ELEMENTS[49917] = Fluid3D([17370,17332,17057,17563],0); -ELEMENTS[49918] = Fluid3D([17332,17057,17563,17313],0); -ELEMENTS[49919] = Fluid3D([17332,17057,17313,17272],0); -ELEMENTS[49920] = Fluid3D([17521,17471,17584,16987],0); -ELEMENTS[49921] = Fluid3D([9096,9311,8322,8497],0); -ELEMENTS[49922] = Fluid3D([18140,18169,17945,18151],0); -ELEMENTS[49923] = Fluid3D([17945,18140,18151,18164],0); -ELEMENTS[49924] = Fluid3D([17945,18140,18164,18082],0); -ELEMENTS[49925] = Fluid3D([15161,14272,14315,14855],0); -ELEMENTS[49926] = Fluid3D([16091,15675,16291,16460],0); -ELEMENTS[49927] = Fluid3D([16091,15675,16460,16293],0); -ELEMENTS[49928] = Fluid3D([8076,9057,8807,8056],0); -ELEMENTS[49929] = Fluid3D([17544,17225,17164,17569],0); -ELEMENTS[49930] = Fluid3D([16673,16199,16692,16563],0); -ELEMENTS[49931] = Fluid3D([16872,16538,16817,16673],0); -ELEMENTS[49932] = Fluid3D([16538,16817,16673,16336],0); -ELEMENTS[49933] = Fluid3D([16817,16996,17284,17047],0); -ELEMENTS[49934] = Fluid3D([16733,16458,16393,15958],0); -ELEMENTS[49935] = Fluid3D([16673,16538,16199,16872],0); -ELEMENTS[49936] = Fluid3D([16817,16996,17047,16733],0); -ELEMENTS[49937] = Fluid3D([16237,16673,16427,16813],0); -ELEMENTS[49938] = Fluid3D([16559,16884,16813,16637],0); -ELEMENTS[49939] = Fluid3D([6980,7151,6272,6959],0); -ELEMENTS[49940] = Fluid3D([15510,15399,15364,16000],0); -ELEMENTS[49941] = Fluid3D([7297,7706,7094,7820],0); -ELEMENTS[49942] = Fluid3D([14289,14910,14133,14904],0); -ELEMENTS[49943] = Fluid3D([7632,7594,6801,7274],0); -ELEMENTS[49944] = Fluid3D([16434,16351,16246,16834],0); -ELEMENTS[49945] = Fluid3D([17187,17051,17154,16619],0); -ELEMENTS[49946] = Fluid3D([11935,11383,11945,11189],0); -ELEMENTS[49947] = Fluid3D([11604,11609,11367,12348],0); -ELEMENTS[49948] = Fluid3D([6091,6257,7117,6456],0); -ELEMENTS[49949] = Fluid3D([8687,9352,8832,9566],0); -ELEMENTS[49950] = Fluid3D([3766,4240,3799,3741],0); -ELEMENTS[49951] = Fluid3D([13122,13656,12965,12817],0); -ELEMENTS[49952] = Fluid3D([3957,4090,4107,4620],0); -ELEMENTS[49953] = Fluid3D([16882,17076,17178,16876],0); -ELEMENTS[49954] = Fluid3D([2344,2437,2279,2132],0); -ELEMENTS[49955] = Fluid3D([5907,5794,6513,6572],0); -ELEMENTS[49956] = Fluid3D([7814,7508,8180,8346],0); -ELEMENTS[49957] = Fluid3D([16393,15958,16462,16733],0); -ELEMENTS[49958] = Fluid3D([15739,16237,15906,15592],0); -ELEMENTS[49959] = Fluid3D([15845,15958,16393,16458],0); -ELEMENTS[49960] = Fluid3D([10711,9792,9475,10234],0); -ELEMENTS[49961] = Fluid3D([12119,11917,11204,11617],0); -ELEMENTS[49962] = Fluid3D([3638,3743,3879,4088],0); -ELEMENTS[49963] = Fluid3D([7814,7508,8346,8368],0); -ELEMENTS[49964] = Fluid3D([16427,16673,16692,17115],0); -ELEMENTS[49965] = Fluid3D([16336,16673,16237,16733],0); -ELEMENTS[49966] = Fluid3D([15906,16427,16133,16237],0); -ELEMENTS[49967] = Fluid3D([16559,16550,16133,16813],0); -ELEMENTS[49968] = Fluid3D([17076,17178,16876,16720],0); -ELEMENTS[49969] = Fluid3D([17178,16876,16720,16931],0); -ELEMENTS[49970] = Fluid3D([15958,15845,16237,16458],0); -ELEMENTS[49971] = Fluid3D([2344,2437,2132,2264],0); -ELEMENTS[49972] = Fluid3D([8180,7814,8346,9030],0); -ELEMENTS[49973] = Fluid3D([13122,13656,12817,13489],0); -ELEMENTS[49974] = Fluid3D([7814,8346,9030,7993],0); -ELEMENTS[49975] = Fluid3D([8346,9030,7993,8368],0); -ELEMENTS[49976] = Fluid3D([7814,8346,7993,8368],0); -ELEMENTS[49977] = Fluid3D([15845,16336,16237,16458],0); -ELEMENTS[49978] = Fluid3D([9792,9475,10234,9130],0); -ELEMENTS[49979] = Fluid3D([6980,7151,6959,7863],0); -ELEMENTS[49980] = Fluid3D([16427,16133,16237,16813],0); -ELEMENTS[49981] = Fluid3D([16393,15845,16458,15846],0); -ELEMENTS[49982] = Fluid3D([2344,2437,2264,2578],0); -ELEMENTS[49983] = Fluid3D([17178,16882,16876,17176],0); -ELEMENTS[49984] = Fluid3D([16876,17178,17176,17190],0); -ELEMENTS[49985] = Fluid3D([15958,16118,16462,15915],0); -ELEMENTS[49986] = Fluid3D([4090,4107,4620,4639],0); -ELEMENTS[49987] = Fluid3D([4090,4107,4639,3826],0); -ELEMENTS[49988] = Fluid3D([4090,4107,3826,3676],0); -ELEMENTS[49989] = Fluid3D([15592,15958,16237,16133],0); -ELEMENTS[49990] = Fluid3D([6091,6257,6456,5969],0); -ELEMENTS[49991] = Fluid3D([16336,16237,16458,16733],0); -ELEMENTS[49992] = Fluid3D([16237,16458,16733,15958],0); -ELEMENTS[49993] = Fluid3D([16458,16336,16733,16817],0); -ELEMENTS[49994] = Fluid3D([16673,16237,16733,16813],0); -ELEMENTS[49995] = Fluid3D([15315,15969,15692,16020],0); -ELEMENTS[49996] = Fluid3D([2096,2065,2086,2213],0); -ELEMENTS[49997] = Fluid3D([8574,8302,9216,8918],0); -ELEMENTS[49998] = Fluid3D([6317,5733,6532,5853],0); -ELEMENTS[49999] = Fluid3D([14754,14079,14537,14550],0); -ELEMENTS[50000] = Fluid3D([14537,14754,14550,15393],0); -ELEMENTS[50001] = Fluid3D([8303,8706,8736,9412],0); -ELEMENTS[50002] = Fluid3D([16741,17036,17166,17107],0); -ELEMENTS[50003] = Fluid3D([16741,17036,17107,17234],0); -ELEMENTS[50004] = Fluid3D([10374,9692,9325,10188],0); -ELEMENTS[50005] = Fluid3D([6278,6871,6301,5778],0); -ELEMENTS[50006] = Fluid3D([8668,7828,8424,8968],0); -ELEMENTS[50007] = Fluid3D([15491,15014,15515,15006],0); -ELEMENTS[50008] = Fluid3D([15515,15491,15006,14844],0); -ELEMENTS[50009] = Fluid3D([15491,15006,14844,15074],0); -ELEMENTS[50010] = Fluid3D([15006,14844,15074,14360],0); -ELEMENTS[50011] = Fluid3D([15006,14844,14360,14637],0); -ELEMENTS[50012] = Fluid3D([15491,15006,15074,14360],0); -ELEMENTS[50013] = Fluid3D([15006,14844,14637,15515],0); -ELEMENTS[50014] = Fluid3D([15491,15014,15006,14360],0); -ELEMENTS[50015] = Fluid3D([5313,4902,5278,4890],0); -ELEMENTS[50016] = Fluid3D([4902,5278,4890,4730],0); -ELEMENTS[50017] = Fluid3D([5278,5313,4890,4963],0); -ELEMENTS[50018] = Fluid3D([4890,5278,4963,5266],0); -ELEMENTS[50019] = Fluid3D([4890,5278,5266,4850],0); -ELEMENTS[50020] = Fluid3D([14534,14824,14783,14957],0); -ELEMENTS[50021] = Fluid3D([4805,4262,4495,4098],0); -ELEMENTS[50022] = Fluid3D([4262,4495,4098,3900],0); -ELEMENTS[50023] = Fluid3D([6405,5809,5898,5637],0); -ELEMENTS[50024] = Fluid3D([5809,5898,5637,5087],0); -ELEMENTS[50025] = Fluid3D([9755,8936,8781,9845],0); -ELEMENTS[50026] = Fluid3D([8634,8590,8065,7776],0); -ELEMENTS[50027] = Fluid3D([8634,8590,7776,7970],0); -ELEMENTS[50028] = Fluid3D([8590,8065,7776,7867],0); -ELEMENTS[50029] = Fluid3D([7776,8590,7867,8785],0); -ELEMENTS[50030] = Fluid3D([8065,7776,7867,6978],0); -ELEMENTS[50031] = Fluid3D([7776,7867,6978,7188],0); -ELEMENTS[50032] = Fluid3D([16177,15591,15874,15879],0); -ELEMENTS[50033] = Fluid3D([13575,13645,14375,13872],0); -ELEMENTS[50034] = Fluid3D([13970,13503,13703,14301],0); -ELEMENTS[50035] = Fluid3D([14665,14125,14350,13990],0); -ELEMENTS[50036] = Fluid3D([5945,5482,5570,5415],0); -ELEMENTS[50037] = Fluid3D([12655,12195,13059,12156],0); -ELEMENTS[50038] = Fluid3D([12655,12195,12156,11944],0); -ELEMENTS[50039] = Fluid3D([7374,6945,7118,7904],0); -ELEMENTS[50040] = Fluid3D([11639,11021,11102,12025],0); -ELEMENTS[50041] = Fluid3D([11021,11102,12025,10619],0); -ELEMENTS[50042] = Fluid3D([6217,5835,6297,6459],0); -ELEMENTS[50043] = Fluid3D([5640,5411,5557,5887],0); -ELEMENTS[50044] = Fluid3D([5411,5557,5887,5267],0); -ELEMENTS[50045] = Fluid3D([5557,5887,5267,5468],0); -ELEMENTS[50046] = Fluid3D([5557,5640,5887,6259],0); -ELEMENTS[50047] = Fluid3D([5557,5887,5468,6076],0); -ELEMENTS[50048] = Fluid3D([5557,5887,6076,6259],0); -ELEMENTS[50049] = Fluid3D([5887,5468,6076,5769],0); -ELEMENTS[50050] = Fluid3D([6076,5887,5769,6711],0); -ELEMENTS[50051] = Fluid3D([5411,5557,5267,5082],0); -ELEMENTS[50052] = Fluid3D([11941,11784,12329,12716],0); -ELEMENTS[50053] = Fluid3D([11784,12329,12716,12225],0); -ELEMENTS[50054] = Fluid3D([11784,12329,12225,11826],0); -ELEMENTS[50055] = Fluid3D([17662,17989,17910,17757],0); -ELEMENTS[50056] = Fluid3D([17910,17662,17757,17669],0); -ELEMENTS[50057] = Fluid3D([17402,17231,16909,17235],0); -ELEMENTS[50058] = Fluid3D([2745,2748,2849,3127],0); -ELEMENTS[50059] = Fluid3D([15352,14948,15431,14708],0); -ELEMENTS[50060] = Fluid3D([5073,5329,4564,4814],0); -ELEMENTS[50061] = Fluid3D([4564,5073,4814,4965],0); -ELEMENTS[50062] = Fluid3D([5073,5329,4814,5543],0); -ELEMENTS[50063] = Fluid3D([12146,12223,12945,12241],0); -ELEMENTS[50064] = Fluid3D([3331,2988,3020,2981],0); -ELEMENTS[50065] = Fluid3D([9152,9752,10238,8970],0); -ELEMENTS[50066] = Fluid3D([10866,10296,10333,10241],0); -ELEMENTS[50067] = Fluid3D([10249,9959,10277,9265],0); -ELEMENTS[50068] = Fluid3D([5652,5610,6189,5941],0); -ELEMENTS[50069] = Fluid3D([15082,15679,15429,15814],0); -ELEMENTS[50070] = Fluid3D([17562,17231,17516,17284],0); -ELEMENTS[50071] = Fluid3D([16421,15947,16179,15636],0); -ELEMENTS[50072] = Fluid3D([15488,15379,15802,15853],0); -ELEMENTS[50073] = Fluid3D([15379,15802,15853,15487],0); -ELEMENTS[50074] = Fluid3D([15488,15379,15853,15370],0); -ELEMENTS[50075] = Fluid3D([15853,15379,15487,15370],0); -ELEMENTS[50076] = Fluid3D([8206,8148,8682,8032],0); -ELEMENTS[50077] = Fluid3D([8206,8148,8032,7274],0); -ELEMENTS[50078] = Fluid3D([5392,5112,5690,5328],0); -ELEMENTS[50079] = Fluid3D([6203,5581,5632,5545],0); -ELEMENTS[50080] = Fluid3D([7880,8427,8819,9113],0); -ELEMENTS[50081] = Fluid3D([8819,7880,9113,8649],0); -ELEMENTS[50082] = Fluid3D([9113,8819,8649,9809],0); -ELEMENTS[50083] = Fluid3D([9113,8819,9809,9623],0); -ELEMENTS[50084] = Fluid3D([9113,8819,9623,9319],0); -ELEMENTS[50085] = Fluid3D([9809,9113,9623,10401],0); -ELEMENTS[50086] = Fluid3D([9623,9809,10401,9850],0); -ELEMENTS[50087] = Fluid3D([10401,9623,9850,9319],0); -ELEMENTS[50088] = Fluid3D([10401,9623,9319,9839],0); -ELEMENTS[50089] = Fluid3D([9623,9319,9839,9113],0); -ELEMENTS[50090] = Fluid3D([10401,9623,9839,9113],0); -ELEMENTS[50091] = Fluid3D([7267,7652,7627,8374],0); -ELEMENTS[50092] = Fluid3D([15903,15465,15945,15405],0); -ELEMENTS[50093] = Fluid3D([14958,15540,15595,15489],0); -ELEMENTS[50094] = Fluid3D([15595,14958,15489,15077],0); -ELEMENTS[50095] = Fluid3D([15489,15595,15077,15476],0); -ELEMENTS[50096] = Fluid3D([15077,15489,15476,14816],0); -ELEMENTS[50097] = Fluid3D([15595,14958,15077,15262],0); -ELEMENTS[50098] = Fluid3D([14958,15489,15077,14085],0); -ELEMENTS[50099] = Fluid3D([2455,2714,2652,2733],0); -ELEMENTS[50100] = Fluid3D([15556,15384,15128,15890],0); -ELEMENTS[50101] = Fluid3D([10327,11330,10956,10743],0); -ELEMENTS[50102] = Fluid3D([9243,8446,9661,8773],0); -ELEMENTS[50103] = Fluid3D([8446,9661,8773,9089],0); -ELEMENTS[50104] = Fluid3D([8773,8446,9089,8269],0); -ELEMENTS[50105] = Fluid3D([9243,8446,8773,8792],0); -ELEMENTS[50106] = Fluid3D([9661,9243,8773,8792],0); -ELEMENTS[50107] = Fluid3D([9661,8773,9089,9366],0); -ELEMENTS[50108] = Fluid3D([9661,8773,9366,9320],0); -ELEMENTS[50109] = Fluid3D([8773,9366,9320,8591],0); -ELEMENTS[50110] = Fluid3D([9661,8773,9320,9491],0); -ELEMENTS[50111] = Fluid3D([8773,9320,9491,8556],0); -ELEMENTS[50112] = Fluid3D([9320,9491,8556,8591],0); -ELEMENTS[50113] = Fluid3D([9320,9491,8591,9788],0); -ELEMENTS[50114] = Fluid3D([9320,9491,9788,10215],0); -ELEMENTS[50115] = Fluid3D([8773,9320,8556,8591],0); -ELEMENTS[50116] = Fluid3D([9320,9491,10215,9661],0); -ELEMENTS[50117] = Fluid3D([8773,9089,9366,8269],0); -ELEMENTS[50118] = Fluid3D([7104,7566,6650,7484],0); -ELEMENTS[50119] = Fluid3D([14587,15038,14935,15469],0); -ELEMENTS[50120] = Fluid3D([17787,17441,17417,17884],0); -ELEMENTS[50121] = Fluid3D([9293,8372,8585,9064],0); -ELEMENTS[50122] = Fluid3D([16167,16068,16611,16194],0); -ELEMENTS[50123] = Fluid3D([10575,10005,10369,10764],0); -ELEMENTS[50124] = Fluid3D([10369,10575,10764,11620],0); -ELEMENTS[50125] = Fluid3D([14518,14144,14156,13652],0); -ELEMENTS[50126] = Fluid3D([9312,9205,10049,10363],0); -ELEMENTS[50127] = Fluid3D([6218,6113,6341,5833],0); -ELEMENTS[50128] = Fluid3D([16491,16680,16757,16954],0); -ELEMENTS[50129] = Fluid3D([4462,4887,4496,4891],0); -ELEMENTS[50130] = Fluid3D([6249,5681,6238,6062],0); -ELEMENTS[50131] = Fluid3D([13232,13193,13715,13139],0); -ELEMENTS[50132] = Fluid3D([13232,13193,13139,12373],0); -ELEMENTS[50133] = Fluid3D([15313,15680,14960,15683],0); -ELEMENTS[50134] = Fluid3D([5978,5408,5694,5719],0); -ELEMENTS[50135] = Fluid3D([2913,3118,2840,3381],0); -ELEMENTS[50136] = Fluid3D([17802,17796,17982,17530],0); -ELEMENTS[50137] = Fluid3D([17083,17220,16926,16551],0); -ELEMENTS[50138] = Fluid3D([6740,6886,7238,6656],0); -ELEMENTS[50139] = Fluid3D([13162,13640,13728,13567],0); -ELEMENTS[50140] = Fluid3D([15811,15495,16049,15752],0); -ELEMENTS[50141] = Fluid3D([7938,8074,7823,8886],0); -ELEMENTS[50142] = Fluid3D([7938,8074,8886,8814],0); -ELEMENTS[50143] = Fluid3D([7921,8342,8756,8503],0); -ELEMENTS[50144] = Fluid3D([6373,6604,7069,6405],0); -ELEMENTS[50145] = Fluid3D([18223,18124,18379,18325],0); -ELEMENTS[50146] = Fluid3D([2925,3367,3204,3224],0); -ELEMENTS[50147] = Fluid3D([8132,7431,7578,7692],0); -ELEMENTS[50148] = Fluid3D([6471,6939,6715,7109],0); -ELEMENTS[50149] = Fluid3D([16115,16484,16763,16603],0); -ELEMENTS[50150] = Fluid3D([16115,16484,16603,16177],0); -ELEMENTS[50151] = Fluid3D([16484,16763,16603,17142],0); -ELEMENTS[50152] = Fluid3D([18220,18099,18057,17843],0); -ELEMENTS[50153] = Fluid3D([6055,6318,5801,5457],0); -ELEMENTS[50154] = Fluid3D([13389,12843,12981,12391],0); -ELEMENTS[50155] = Fluid3D([13389,12843,12391,13680],0); -ELEMENTS[50156] = Fluid3D([8694,8668,8915,8021],0); -ELEMENTS[50157] = Fluid3D([17282,17537,17076,17484],0); -ELEMENTS[50158] = Fluid3D([10943,10642,10536,11827],0); -ELEMENTS[50159] = Fluid3D([14289,14848,14961,14872],0); -ELEMENTS[50160] = Fluid3D([12865,13146,13669,13304],0); -ELEMENTS[50161] = Fluid3D([5753,5285,5243,5347],0); -ELEMENTS[50162] = Fluid3D([7771,7780,7254,6715],0); -ELEMENTS[50163] = Fluid3D([14149,14125,13791,13660],0); -ELEMENTS[50164] = Fluid3D([8081,8499,7840,7585],0); -ELEMENTS[50165] = Fluid3D([8081,8499,7585,8519],0); -ELEMENTS[50166] = Fluid3D([7886,7483,7851,7459],0); -ELEMENTS[50167] = Fluid3D([7483,7851,7459,6969],0); -ELEMENTS[50168] = Fluid3D([7851,7459,6969,7609],0); -ELEMENTS[50169] = Fluid3D([7851,7459,7609,8441],0); -ELEMENTS[50170] = Fluid3D([7459,6969,7609,6995],0); -ELEMENTS[50171] = Fluid3D([7609,7459,6995,7996],0); -ELEMENTS[50172] = Fluid3D([7851,7459,8441,7886],0); -ELEMENTS[50173] = Fluid3D([7609,7459,7996,8441],0); -ELEMENTS[50174] = Fluid3D([10631,10233,11407,10882],0); -ELEMENTS[50175] = Fluid3D([10233,11407,10882,10810],0); -ELEMENTS[50176] = Fluid3D([15793,15745,15966,15417],0); -ELEMENTS[50177] = Fluid3D([9575,9642,10335,9353],0); -ELEMENTS[50178] = Fluid3D([9575,9642,9353,8757],0); -ELEMENTS[50179] = Fluid3D([2275,2185,2311,2083],0); -ELEMENTS[50180] = Fluid3D([3357,3064,3420,3351],0); -ELEMENTS[50181] = Fluid3D([15586,16046,15914,15638],0); -ELEMENTS[50182] = Fluid3D([10016,10724,10492,11483],0); -ELEMENTS[50183] = Fluid3D([6954,6935,6912,7791],0); -ELEMENTS[50184] = Fluid3D([12001,11173,12152,11236],0); -ELEMENTS[50185] = Fluid3D([5470,5606,5848,6091],0); -ELEMENTS[50186] = Fluid3D([7545,7293,7910,8469],0); -ELEMENTS[50187] = Fluid3D([18400,18395,18285,18195],0); -ELEMENTS[50188] = Fluid3D([18400,18395,18195,18216],0); -ELEMENTS[50189] = Fluid3D([18285,18400,18195,18261],0); -ELEMENTS[50190] = Fluid3D([17360,17646,17626,17154],0); -ELEMENTS[50191] = Fluid3D([17360,17646,17154,17271],0); -ELEMENTS[50192] = Fluid3D([5462,6104,6212,5633],0); -ELEMENTS[50193] = Fluid3D([10249,10940,10668,11509],0); -ELEMENTS[50194] = Fluid3D([17921,18203,18156,18197],0); -ELEMENTS[50195] = Fluid3D([18203,18156,18197,18342],0); -ELEMENTS[50196] = Fluid3D([18156,18197,18342,18275],0); -ELEMENTS[50197] = Fluid3D([18156,18197,18275,17934],0); -ELEMENTS[50198] = Fluid3D([18342,18156,18275,18093],0); -ELEMENTS[50199] = Fluid3D([18203,18156,18342,18356],0); -ELEMENTS[50200] = Fluid3D([18197,18342,18275,18322],0); -ELEMENTS[50201] = Fluid3D([18156,17921,18197,17934],0); -ELEMENTS[50202] = Fluid3D([18275,18197,18322,18109],0); -ELEMENTS[50203] = Fluid3D([18322,18275,18109,18201],0); -ELEMENTS[50204] = Fluid3D([18275,18197,18109,17934],0); -ELEMENTS[50205] = Fluid3D([18322,18275,18201,18461],0); -ELEMENTS[50206] = Fluid3D([13480,13672,14281,13493],0); -ELEMENTS[50207] = Fluid3D([18691,18679,18692,18696],0); -ELEMENTS[50208] = Fluid3D([4223,4300,4349,3813],0); -ELEMENTS[50209] = Fluid3D([3438,3788,3882,3779],0); -ELEMENTS[50210] = Fluid3D([5549,6119,6084,6268],0); -ELEMENTS[50211] = Fluid3D([6119,6084,6268,7027],0); -ELEMENTS[50212] = Fluid3D([16059,16307,16051,16759],0); -ELEMENTS[50213] = Fluid3D([12890,11773,12180,12965],0); -ELEMENTS[50214] = Fluid3D([6915,6351,6768,7190],0); -ELEMENTS[50215] = Fluid3D([14070,13864,13677,13077],0); -ELEMENTS[50216] = Fluid3D([14070,13864,13077,13743],0); -ELEMENTS[50217] = Fluid3D([6405,6946,6888,7450],0); -ELEMENTS[50218] = Fluid3D([6272,6841,6363,6475],0); -ELEMENTS[50219] = Fluid3D([6841,6363,6475,6839],0); -ELEMENTS[50220] = Fluid3D([6363,6272,6475,5740],0); -ELEMENTS[50221] = Fluid3D([6010,6363,6475,5740],0); -ELEMENTS[50222] = Fluid3D([6010,6363,5740,5385],0); -ELEMENTS[50223] = Fluid3D([6475,6010,5740,5521],0); -ELEMENTS[50224] = Fluid3D([6010,5740,5521,5385],0); -ELEMENTS[50225] = Fluid3D([17226,17040,17440,17579],0); -ELEMENTS[50226] = Fluid3D([6390,6805,6978,6181],0); -ELEMENTS[50227] = Fluid3D([18023,18265,18245,18254],0); -ELEMENTS[50228] = Fluid3D([9171,10054,9127,10271],0); -ELEMENTS[50229] = Fluid3D([8202,8496,8822,9109],0); -ELEMENTS[50230] = Fluid3D([12794,12480,11850,13149],0); -ELEMENTS[50231] = Fluid3D([12794,12480,13149,13336],0); -ELEMENTS[50232] = Fluid3D([2890,3050,2988,2649],0); -ELEMENTS[50233] = Fluid3D([2715,2420,2564,2995],0); -ELEMENTS[50234] = Fluid3D([6895,7190,7456,6768],0); -ELEMENTS[50235] = Fluid3D([14937,15584,14936,14436],0); -ELEMENTS[50236] = Fluid3D([8519,7825,8723,8583],0); -ELEMENTS[50237] = Fluid3D([16395,16705,16221,16985],0); -ELEMENTS[50238] = Fluid3D([11144,11619,11684,12399],0); -ELEMENTS[50239] = Fluid3D([15951,16319,15543,16263],0); -ELEMENTS[50240] = Fluid3D([7104,6801,7484,6612],0); -ELEMENTS[50241] = Fluid3D([7104,6801,6612,6099],0); -ELEMENTS[50242] = Fluid3D([6801,6612,6099,6232],0); -ELEMENTS[50243] = Fluid3D([6612,6099,6232,5749],0); -ELEMENTS[50244] = Fluid3D([6099,6232,5749,5624],0); -ELEMENTS[50245] = Fluid3D([6099,6232,5624,6118],0); -ELEMENTS[50246] = Fluid3D([5749,6099,5624,5162],0); -ELEMENTS[50247] = Fluid3D([6612,6099,5749,5975],0); -ELEMENTS[50248] = Fluid3D([6099,5749,5975,5162],0); -ELEMENTS[50249] = Fluid3D([6612,6099,5975,7104],0); -ELEMENTS[50250] = Fluid3D([7484,7104,6612,6650],0); -ELEMENTS[50251] = Fluid3D([7104,6612,6650,5975],0); -ELEMENTS[50252] = Fluid3D([6612,6650,5975,6369],0); -ELEMENTS[50253] = Fluid3D([6612,6650,6369,7209],0); -ELEMENTS[50254] = Fluid3D([6612,6650,7209,7484],0); -ELEMENTS[50255] = Fluid3D([7209,6612,7484,6967],0); -ELEMENTS[50256] = Fluid3D([6369,6612,7209,6967],0); -ELEMENTS[50257] = Fluid3D([5749,6612,5975,6369],0); -ELEMENTS[50258] = Fluid3D([6099,6801,6232,6118],0); -ELEMENTS[50259] = Fluid3D([14483,14173,14619,13911],0); -ELEMENTS[50260] = Fluid3D([14173,14619,13911,13889],0); -ELEMENTS[50261] = Fluid3D([14173,14619,13889,14766],0); -ELEMENTS[50262] = Fluid3D([14173,14619,14766,14503],0); -ELEMENTS[50263] = Fluid3D([14483,14173,13911,13377],0); -ELEMENTS[50264] = Fluid3D([14173,13911,13377,13889],0); -ELEMENTS[50265] = Fluid3D([13889,14173,14766,13893],0); -ELEMENTS[50266] = Fluid3D([14766,14173,14503,13984],0); -ELEMENTS[50267] = Fluid3D([4698,4321,4617,3894],0); -ELEMENTS[50268] = Fluid3D([15009,14419,15372,15113],0); -ELEMENTS[50269] = Fluid3D([18652,18588,18574,18626],0); -ELEMENTS[50270] = Fluid3D([3247,3438,3423,3863],0); -ELEMENTS[50271] = Fluid3D([8951,9239,10112,9266],0); -ELEMENTS[50272] = Fluid3D([17755,17946,17638,18078],0); -ELEMENTS[50273] = Fluid3D([14048,13871,14161,13529],0); -ELEMENTS[50274] = Fluid3D([14161,14048,13529,14431],0); -ELEMENTS[50275] = Fluid3D([2840,2779,3112,2639],0); -ELEMENTS[50276] = Fluid3D([2840,2779,2639,2527],0); -ELEMENTS[50277] = Fluid3D([3112,2840,2639,2805],0); -ELEMENTS[50278] = Fluid3D([2840,2639,2805,2527],0); -ELEMENTS[50279] = Fluid3D([6871,7081,7413,6299],0); -ELEMENTS[50280] = Fluid3D([4285,4413,4321,4617],0); -ELEMENTS[50281] = Fluid3D([4321,4285,4617,3894],0); -ELEMENTS[50282] = Fluid3D([4285,4413,4617,4946],0); -ELEMENTS[50283] = Fluid3D([18545,18436,18443,18492],0); -ELEMENTS[50284] = Fluid3D([18545,18436,18492,18577],0); -ELEMENTS[50285] = Fluid3D([8751,8640,7777,8163],0); -ELEMENTS[50286] = Fluid3D([3809,3882,3636,4033],0); -ELEMENTS[50287] = Fluid3D([5913,5288,5832,5964],0); -ELEMENTS[50288] = Fluid3D([5561,5509,5476,6044],0); -ELEMENTS[50289] = Fluid3D([5476,5561,6044,6283],0); -ELEMENTS[50290] = Fluid3D([5561,5509,6044,5870],0); -ELEMENTS[50291] = Fluid3D([6044,5561,5870,5808],0); -ELEMENTS[50292] = Fluid3D([5561,5870,5808,5523],0); -ELEMENTS[50293] = Fluid3D([5870,5808,5523,6131],0); -ELEMENTS[50294] = Fluid3D([5523,5870,6131,5188],0); -ELEMENTS[50295] = Fluid3D([5870,5808,6131,6619],0); -ELEMENTS[50296] = Fluid3D([5523,5870,5188,5509],0); -ELEMENTS[50297] = Fluid3D([5509,6044,5870,6131],0); -ELEMENTS[50298] = Fluid3D([5561,5509,5870,5523],0); -ELEMENTS[50299] = Fluid3D([6044,5870,6131,6619],0); -ELEMENTS[50300] = Fluid3D([6044,5561,5808,6283],0); -ELEMENTS[50301] = Fluid3D([5808,5561,5523,4998],0); -ELEMENTS[50302] = Fluid3D([10864,11322,10550,12021],0); -ELEMENTS[50303] = Fluid3D([13882,14374,14085,14958],0); -ELEMENTS[50304] = Fluid3D([15671,15255,15717,15026],0); -ELEMENTS[50305] = Fluid3D([7725,7609,6750,7218],0); -ELEMENTS[50306] = Fluid3D([7652,7410,8089,7849],0); -ELEMENTS[50307] = Fluid3D([13357,14148,13309,13771],0); -ELEMENTS[50308] = Fluid3D([13309,13357,13771,12816],0); -ELEMENTS[50309] = Fluid3D([13771,13309,12816,13851],0); -ELEMENTS[50310] = Fluid3D([13771,13309,13851,14148],0); -ELEMENTS[50311] = Fluid3D([7943,8284,8322,9215],0); -ELEMENTS[50312] = Fluid3D([12485,12073,13015,12666],0); -ELEMENTS[50313] = Fluid3D([12485,12073,12666,11542],0); -ELEMENTS[50314] = Fluid3D([13015,12485,12666,13251],0); -ELEMENTS[50315] = Fluid3D([12485,12666,13251,12586],0); -ELEMENTS[50316] = Fluid3D([12485,12666,12586,11542],0); -ELEMENTS[50317] = Fluid3D([12073,13015,12666,12551],0); -ELEMENTS[50318] = Fluid3D([12666,12073,12551,11474],0); -ELEMENTS[50319] = Fluid3D([12666,12073,11474,11542],0); -ELEMENTS[50320] = Fluid3D([13167,12556,13031,12346],0); -ELEMENTS[50321] = Fluid3D([13167,12556,12346,12482],0); -ELEMENTS[50322] = Fluid3D([12346,13167,12482,12421],0); -ELEMENTS[50323] = Fluid3D([12482,12346,12421,11440],0); -ELEMENTS[50324] = Fluid3D([12482,12346,11440,11732],0); -ELEMENTS[50325] = Fluid3D([12556,12346,12482,11732],0); -ELEMENTS[50326] = Fluid3D([12556,13031,12346,12186],0); -ELEMENTS[50327] = Fluid3D([12346,12421,11440,11610],0); -ELEMENTS[50328] = Fluid3D([12346,12421,11610,12186],0); -ELEMENTS[50329] = Fluid3D([10937,10810,10233,10882],0); -ELEMENTS[50330] = Fluid3D([12400,11837,11467,12315],0); -ELEMENTS[50331] = Fluid3D([9362,8769,9337,9751],0); -ELEMENTS[50332] = Fluid3D([3254,3123,2946,3179],0); -ELEMENTS[50333] = Fluid3D([2310,2261,2550,2193],0); -ELEMENTS[50334] = Fluid3D([9086,8655,9053,8245],0); -ELEMENTS[50335] = Fluid3D([9086,8655,8245,8058],0); -ELEMENTS[50336] = Fluid3D([15305,14738,14657,14414],0); -ELEMENTS[50337] = Fluid3D([13792,13030,13825,14018],0); -ELEMENTS[50338] = Fluid3D([12386,12114,12579,12899],0); -ELEMENTS[50339] = Fluid3D([12386,12114,12899,12251],0); -ELEMENTS[50340] = Fluid3D([12114,12899,12251,12310],0); -ELEMENTS[50341] = Fluid3D([12899,12386,12251,13126],0); -ELEMENTS[50342] = Fluid3D([12251,12899,13126,12310],0); -ELEMENTS[50343] = Fluid3D([12386,12114,12251,11573],0); -ELEMENTS[50344] = Fluid3D([12114,12251,11573,11458],0); -ELEMENTS[50345] = Fluid3D([12251,11573,11458,12202],0); -ELEMENTS[50346] = Fluid3D([12251,12114,12310,11458],0); -ELEMENTS[50347] = Fluid3D([12310,12251,11458,11966],0); -ELEMENTS[50348] = Fluid3D([12251,11458,11966,11669],0); -ELEMENTS[50349] = Fluid3D([11966,12251,11669,13126],0); -ELEMENTS[50350] = Fluid3D([12251,11458,11669,12202],0); -ELEMENTS[50351] = Fluid3D([11669,12251,12202,13126],0); -ELEMENTS[50352] = Fluid3D([11458,11966,11669,10558],0); -ELEMENTS[50353] = Fluid3D([10267,9823,9846,8977],0); -ELEMENTS[50354] = Fluid3D([8629,8811,9459,9559],0); -ELEMENTS[50355] = Fluid3D([8811,9459,9559,9973],0); -ELEMENTS[50356] = Fluid3D([9459,8629,9559,9379],0); -ELEMENTS[50357] = Fluid3D([8629,8811,9559,8469],0); -ELEMENTS[50358] = Fluid3D([8811,9559,8469,9646],0); -ELEMENTS[50359] = Fluid3D([8629,9559,9379,9289],0); -ELEMENTS[50360] = Fluid3D([8811,9559,9646,9973],0); -ELEMENTS[50361] = Fluid3D([9559,9646,9973,10542],0); -ELEMENTS[50362] = Fluid3D([9559,9459,9379,9957],0); -ELEMENTS[50363] = Fluid3D([9559,9459,9957,9973],0); -ELEMENTS[50364] = Fluid3D([9379,9559,9957,10410],0); -ELEMENTS[50365] = Fluid3D([2260,2334,2413,2644],0); -ELEMENTS[50366] = Fluid3D([5645,5709,5950,5378],0); -ELEMENTS[50367] = Fluid3D([2322,2379,2114,2182],0); -ELEMENTS[50368] = Fluid3D([2904,3014,2644,2748],0); -ELEMENTS[50369] = Fluid3D([2904,3014,2748,3127],0); -ELEMENTS[50370] = Fluid3D([16331,16101,16590,16712],0); -ELEMENTS[50371] = Fluid3D([13868,13190,14361,13955],0); -ELEMENTS[50372] = Fluid3D([5714,5584,5338,4800],0); -ELEMENTS[50373] = Fluid3D([16132,16014,16200,16453],0); -ELEMENTS[50374] = Fluid3D([16132,16014,16453,16586],0); -ELEMENTS[50375] = Fluid3D([6111,6079,5804,5466],0); -ELEMENTS[50376] = Fluid3D([17912,17933,17653,17592],0); -ELEMENTS[50377] = Fluid3D([5132,5184,4858,4463],0); -ELEMENTS[50378] = Fluid3D([13982,14544,13642,13461],0); -ELEMENTS[50379] = Fluid3D([12984,12409,13686,13271],0); -ELEMENTS[50380] = Fluid3D([6726,7267,6894,6173],0); -ELEMENTS[50381] = Fluid3D([1711,1818,1804,1721],0); -ELEMENTS[50382] = Fluid3D([13475,13912,13403,13083],0); -ELEMENTS[50383] = Fluid3D([13475,13912,13083,13569],0); -ELEMENTS[50384] = Fluid3D([13475,13912,13569,14460],0); -ELEMENTS[50385] = Fluid3D([13912,13083,13569,13454],0); -ELEMENTS[50386] = Fluid3D([13083,13569,13454,12922],0); -ELEMENTS[50387] = Fluid3D([13912,13083,13454,13688],0); -ELEMENTS[50388] = Fluid3D([13083,13475,13569,12737],0); -ELEMENTS[50389] = Fluid3D([13569,13912,13454,14460],0); -ELEMENTS[50390] = Fluid3D([13083,13454,13688,12606],0); -ELEMENTS[50391] = Fluid3D([13083,13454,12606,12220],0); -ELEMENTS[50392] = Fluid3D([12606,13083,12220,12301],0); -ELEMENTS[50393] = Fluid3D([13083,12220,12301,12922],0); -ELEMENTS[50394] = Fluid3D([12220,12606,12301,11687],0); -ELEMENTS[50395] = Fluid3D([12606,13083,12301,13403],0); -ELEMENTS[50396] = Fluid3D([13569,13454,12922,13943],0); -ELEMENTS[50397] = Fluid3D([13569,13454,13943,14460],0); -ELEMENTS[50398] = Fluid3D([13943,13569,14460,13754],0); -ELEMENTS[50399] = Fluid3D([13943,13569,13754,12922],0); -ELEMENTS[50400] = Fluid3D([13569,13754,12922,12737],0); -ELEMENTS[50401] = Fluid3D([13569,13754,12737,13475],0); -ELEMENTS[50402] = Fluid3D([13569,14460,13754,13475],0); -ELEMENTS[50403] = Fluid3D([14460,13943,13754,14351],0); -ELEMENTS[50404] = Fluid3D([13083,13454,12220,12922],0); -ELEMENTS[50405] = Fluid3D([3205,2871,2878,2789],0); -ELEMENTS[50406] = Fluid3D([14983,15057,15799,15389],0); -ELEMENTS[50407] = Fluid3D([13544,12766,12624,12499],0); -ELEMENTS[50408] = Fluid3D([4185,4345,4419,4036],0); -ELEMENTS[50409] = Fluid3D([4185,4345,4036,3823],0); -ELEMENTS[50410] = Fluid3D([4345,4036,3823,3949],0); -ELEMENTS[50411] = Fluid3D([18138,18019,18283,18108],0); -ELEMENTS[50412] = Fluid3D([6997,7354,6947,6661],0); -ELEMENTS[50413] = Fluid3D([7354,6947,6661,6960],0); -ELEMENTS[50414] = Fluid3D([6661,7354,6960,7197],0); -ELEMENTS[50415] = Fluid3D([6960,6661,7197,6306],0); -ELEMENTS[50416] = Fluid3D([6947,6661,6960,6251],0); -ELEMENTS[50417] = Fluid3D([6661,6960,6251,6306],0); -ELEMENTS[50418] = Fluid3D([14871,14356,14587,14160],0); -ELEMENTS[50419] = Fluid3D([18432,18399,18401,18518],0); -ELEMENTS[50420] = Fluid3D([10676,10238,9745,9225],0); -ELEMENTS[50421] = Fluid3D([12940,12809,12016,12714],0); -ELEMENTS[50422] = Fluid3D([17469,17515,17136,17014],0); -ELEMENTS[50423] = Fluid3D([3088,3365,3260,3391],0); -ELEMENTS[50424] = Fluid3D([6477,6916,6179,6109],0); -ELEMENTS[50425] = Fluid3D([6477,6916,6109,5997],0); -ELEMENTS[50426] = Fluid3D([6916,6179,6109,6720],0); -ELEMENTS[50427] = Fluid3D([15753,15783,15629,15291],0); -ELEMENTS[50428] = Fluid3D([15740,15970,15852,16138],0); -ELEMENTS[50429] = Fluid3D([15740,15970,16138,16584],0); -ELEMENTS[50430] = Fluid3D([15852,15740,16138,15674],0); -ELEMENTS[50431] = Fluid3D([15740,16138,15674,15865],0); -ELEMENTS[50432] = Fluid3D([15674,15740,15865,14974],0); -ELEMENTS[50433] = Fluid3D([15740,16138,15865,16584],0); -ELEMENTS[50434] = Fluid3D([16138,15852,15674,16056],0); -ELEMENTS[50435] = Fluid3D([16138,15852,16056,16324],0); -ELEMENTS[50436] = Fluid3D([15674,16138,16056,16164],0); -ELEMENTS[50437] = Fluid3D([15852,16056,16324,15828],0); -ELEMENTS[50438] = Fluid3D([16056,16324,15828,16164],0); -ELEMENTS[50439] = Fluid3D([15828,16056,16164,15674],0); -ELEMENTS[50440] = Fluid3D([16138,16056,16164,16633],0); -ELEMENTS[50441] = Fluid3D([16056,16324,16164,16633],0); -ELEMENTS[50442] = Fluid3D([16056,16324,16633,16138],0); -ELEMENTS[50443] = Fluid3D([12813,12159,12302,12128],0); -ELEMENTS[50444] = Fluid3D([3549,3317,3471,3257],0); -ELEMENTS[50445] = Fluid3D([13141,13374,12647,12378],0); -ELEMENTS[50446] = Fluid3D([4803,4618,5120,4907],0); -ELEMENTS[50447] = Fluid3D([8620,8283,8132,7629],0); -ELEMENTS[50448] = Fluid3D([11830,11206,11770,11006],0); -ELEMENTS[50449] = Fluid3D([5392,5871,5416,5413],0); -ELEMENTS[50450] = Fluid3D([6152,6885,6189,6738],0); -ELEMENTS[50451] = Fluid3D([9212,9216,8925,8359],0); -ELEMENTS[50452] = Fluid3D([8925,9212,8359,8375],0); -ELEMENTS[50453] = Fluid3D([4353,4842,4873,4565],0); -ELEMENTS[50454] = Fluid3D([4842,4873,4565,5321],0); -ELEMENTS[50455] = Fluid3D([4842,4873,5321,5379],0); -ELEMENTS[50456] = Fluid3D([14810,15088,15206,14768],0); -ELEMENTS[50457] = Fluid3D([11481,11629,10806,10621],0); -ELEMENTS[50458] = Fluid3D([5202,5565,5971,5752],0); -ELEMENTS[50459] = Fluid3D([5202,5565,5752,5409],0); -ELEMENTS[50460] = Fluid3D([4893,5339,4745,5441],0); -ELEMENTS[50461] = Fluid3D([4893,5339,5441,5809],0); -ELEMENTS[50462] = Fluid3D([4745,4893,5441,5035],0); -ELEMENTS[50463] = Fluid3D([5120,5516,5316,4815],0); -ELEMENTS[50464] = Fluid3D([9802,10895,10514,10964],0); -ELEMENTS[50465] = Fluid3D([12728,11956,12481,11554],0); -ELEMENTS[50466] = Fluid3D([15606,15796,15438,15954],0); -ELEMENTS[50467] = Fluid3D([5283,5384,5980,5921],0); -ELEMENTS[50468] = Fluid3D([5727,6151,5424,5527],0); -ELEMENTS[50469] = Fluid3D([5424,5727,5527,4980],0); -ELEMENTS[50470] = Fluid3D([18054,17993,18099,18324],0); -ELEMENTS[50471] = Fluid3D([7829,8810,8702,8006],0); -ELEMENTS[50472] = Fluid3D([8997,9204,9887,9649],0); -ELEMENTS[50473] = Fluid3D([8997,9204,9649,9474],0); -ELEMENTS[50474] = Fluid3D([9756,10202,9129,10232],0); -ELEMENTS[50475] = Fluid3D([2695,2581,2491,2322],0); -ELEMENTS[50476] = Fluid3D([14112,13040,13535,13313],0); -ELEMENTS[50477] = Fluid3D([17741,17739,17415,17758],0); -ELEMENTS[50478] = Fluid3D([17741,17739,17758,18019],0); -ELEMENTS[50479] = Fluid3D([8475,8339,8955,9309],0); -ELEMENTS[50480] = Fluid3D([11567,12534,12186,11610],0); -ELEMENTS[50481] = Fluid3D([12186,11567,11610,11094],0); -ELEMENTS[50482] = Fluid3D([11567,11610,11094,10551],0); -ELEMENTS[50483] = Fluid3D([11094,11567,10551,10472],0); -ELEMENTS[50484] = Fluid3D([10551,11094,10472,10757],0); -ELEMENTS[50485] = Fluid3D([11610,11094,10551,11013],0); -ELEMENTS[50486] = Fluid3D([11094,10551,11013,10757],0); -ELEMENTS[50487] = Fluid3D([11610,11094,11013,11279],0); -ELEMENTS[50488] = Fluid3D([11013,11610,11279,11732],0); -ELEMENTS[50489] = Fluid3D([11610,11094,11279,12186],0); -ELEMENTS[50490] = Fluid3D([11094,10472,10757,11188],0); -ELEMENTS[50491] = Fluid3D([10757,11094,11188,12186],0); -ELEMENTS[50492] = Fluid3D([11567,12534,11610,11229],0); -ELEMENTS[50493] = Fluid3D([10551,11610,11013,11229],0); -ELEMENTS[50494] = Fluid3D([11610,11279,11732,12186],0); -ELEMENTS[50495] = Fluid3D([2892,2916,2607,3120],0); -ELEMENTS[50496] = Fluid3D([17309,17255,16871,17216],0); -ELEMENTS[50497] = Fluid3D([6297,6859,6333,6250],0); -ELEMENTS[50498] = Fluid3D([11388,10674,11717,10829],0); -ELEMENTS[50499] = Fluid3D([17843,17821,18099,18057],0); -ELEMENTS[50500] = Fluid3D([4482,4646,5194,5129],0); -ELEMENTS[50501] = Fluid3D([13590,13701,14394,14511],0); -ELEMENTS[50502] = Fluid3D([15490,15219,15081,14956],0); -ELEMENTS[50503] = Fluid3D([15081,15490,14956,15083],0); -ELEMENTS[50504] = Fluid3D([15490,14956,15083,15539],0); -ELEMENTS[50505] = Fluid3D([14172,14753,14667,15013],0); -ELEMENTS[50506] = Fluid3D([10217,11012,10087,10268],0); -ELEMENTS[50507] = Fluid3D([6028,6228,6521,6979],0); -ELEMENTS[50508] = Fluid3D([6028,6228,6979,6178],0); -ELEMENTS[50509] = Fluid3D([11321,11387,12141,12675],0); -ELEMENTS[50510] = Fluid3D([5164,5422,5345,5610],0); -ELEMENTS[50511] = Fluid3D([7762,7346,8133,7470],0); -ELEMENTS[50512] = Fluid3D([7762,7346,7470,6693],0); -ELEMENTS[50513] = Fluid3D([8133,7762,7470,8710],0); -ELEMENTS[50514] = Fluid3D([7470,7762,6693,7146],0); -ELEMENTS[50515] = Fluid3D([12991,12321,11925,12529],0); -ELEMENTS[50516] = Fluid3D([12991,12321,12529,12574],0); -ELEMENTS[50517] = Fluid3D([12991,12321,12574,13054],0); -ELEMENTS[50518] = Fluid3D([18345,18243,18428,18442],0); -ELEMENTS[50519] = Fluid3D([2652,2984,2733,2714],0); -ELEMENTS[50520] = Fluid3D([2652,2984,2714,3124],0); -ELEMENTS[50521] = Fluid3D([2714,2402,2667,2751],0); -ELEMENTS[50522] = Fluid3D([16760,16864,16422,16339],0); -ELEMENTS[50523] = Fluid3D([16422,16760,16339,16029],0); -ELEMENTS[50524] = Fluid3D([4214,4569,4724,4351],0); -ELEMENTS[50525] = Fluid3D([4724,4214,4351,4259],0); -ELEMENTS[50526] = Fluid3D([16637,16559,16133,16813],0); -ELEMENTS[50527] = Fluid3D([6389,6706,6900,6215],0); -ELEMENTS[50528] = Fluid3D([17372,17175,17374,17649],0); -ELEMENTS[50529] = Fluid3D([17175,17374,17649,17451],0); -ELEMENTS[50530] = Fluid3D([17374,17372,17649,17384],0); -ELEMENTS[50531] = Fluid3D([17374,17649,17451,17657],0); -ELEMENTS[50532] = Fluid3D([17374,17649,17657,17883],0); -ELEMENTS[50533] = Fluid3D([17649,17657,17883,17835],0); -ELEMENTS[50534] = Fluid3D([17657,17883,17835,18006],0); -ELEMENTS[50535] = Fluid3D([17835,17657,18006,17545],0); -ELEMENTS[50536] = Fluid3D([17835,17657,17545,17451],0); -ELEMENTS[50537] = Fluid3D([17835,17657,17451,17649],0); -ELEMENTS[50538] = Fluid3D([7150,7689,8177,7435],0); -ELEMENTS[50539] = Fluid3D([8177,7150,7435,7305],0); -ELEMENTS[50540] = Fluid3D([7150,7435,7305,6537],0); -ELEMENTS[50541] = Fluid3D([7150,7689,7435,6752],0); -ELEMENTS[50542] = Fluid3D([7435,7150,6752,6537],0); -ELEMENTS[50543] = Fluid3D([16046,16435,15914,16377],0); -ELEMENTS[50544] = Fluid3D([16046,16435,16377,16567],0); -ELEMENTS[50545] = Fluid3D([18471,18358,18327,18456],0); -ELEMENTS[50546] = Fluid3D([8023,7623,7289,8161],0); -ELEMENTS[50547] = Fluid3D([10538,11444,11421,10469],0); -ELEMENTS[50548] = Fluid3D([12345,13438,13148,12676],0); -ELEMENTS[50549] = Fluid3D([17048,16763,16561,16927],0); -ELEMENTS[50550] = Fluid3D([16763,16561,16927,16484],0); -ELEMENTS[50551] = Fluid3D([16763,16561,16484,16146],0); -ELEMENTS[50552] = Fluid3D([16927,16763,16484,17142],0); -ELEMENTS[50553] = Fluid3D([16561,16927,16484,16466],0); -ELEMENTS[50554] = Fluid3D([16484,16561,16466,16045],0); -ELEMENTS[50555] = Fluid3D([16561,16466,16045,16370],0); -ELEMENTS[50556] = Fluid3D([16466,16045,16370,16568],0); -ELEMENTS[50557] = Fluid3D([16370,16466,16568,16937],0); -ELEMENTS[50558] = Fluid3D([16927,16484,16466,16684],0); -ELEMENTS[50559] = Fluid3D([16927,16484,16684,17142],0); -ELEMENTS[50560] = Fluid3D([16484,16466,16684,16130],0); -ELEMENTS[50561] = Fluid3D([16561,16927,16466,16835],0); -ELEMENTS[50562] = Fluid3D([16466,16561,16835,16370],0); -ELEMENTS[50563] = Fluid3D([16835,16466,16370,16937],0); -ELEMENTS[50564] = Fluid3D([16370,16835,16937,16746],0); -ELEMENTS[50565] = Fluid3D([16835,16937,16746,17246],0); -ELEMENTS[50566] = Fluid3D([16835,16466,16937,16927],0); -ELEMENTS[50567] = Fluid3D([16466,16484,16045,16130],0); -ELEMENTS[50568] = Fluid3D([16835,16937,17246,17230],0); -ELEMENTS[50569] = Fluid3D([16835,16937,17230,16927],0); -ELEMENTS[50570] = Fluid3D([17230,16835,16927,17048],0); -ELEMENTS[50571] = Fluid3D([16561,16927,16835,17048],0); -ELEMENTS[50572] = Fluid3D([16466,16927,16684,16568],0); -ELEMENTS[50573] = Fluid3D([16684,16466,16568,16130],0); -ELEMENTS[50574] = Fluid3D([16370,16835,16746,16404],0); -ELEMENTS[50575] = Fluid3D([16835,16746,16404,16892],0); -ELEMENTS[50576] = Fluid3D([16835,16746,16892,17246],0); -ELEMENTS[50577] = Fluid3D([16404,16835,16892,16561],0); -ELEMENTS[50578] = Fluid3D([16404,16835,16561,16370],0); -ELEMENTS[50579] = Fluid3D([16746,16404,16892,16575],0); -ELEMENTS[50580] = Fluid3D([16466,16568,16130,16045],0); -ELEMENTS[50581] = Fluid3D([16937,17246,17230,17404],0); -ELEMENTS[50582] = Fluid3D([17230,16937,17404,17093],0); -ELEMENTS[50583] = Fluid3D([17246,17230,17404,17630],0); -ELEMENTS[50584] = Fluid3D([16746,16370,16404,16166],0); -ELEMENTS[50585] = Fluid3D([16404,16746,16166,16575],0); -ELEMENTS[50586] = Fluid3D([16370,16404,16166,15729],0); -ELEMENTS[50587] = Fluid3D([17404,17230,17093,17125],0); -ELEMENTS[50588] = Fluid3D([17048,16763,16927,17392],0); -ELEMENTS[50589] = Fluid3D([16466,16568,16937,16927],0); -ELEMENTS[50590] = Fluid3D([16561,16484,16146,16045],0); -ELEMENTS[50591] = Fluid3D([12965,12463,11773,11385],0); -ELEMENTS[50592] = Fluid3D([12463,11773,11385,11485],0); -ELEMENTS[50593] = Fluid3D([16399,16128,16478,16329],0); -ELEMENTS[50594] = Fluid3D([16478,16399,16329,16682],0); -ELEMENTS[50595] = Fluid3D([16399,16329,16682,16531],0); -ELEMENTS[50596] = Fluid3D([16478,16399,16682,16403],0); -ELEMENTS[50597] = Fluid3D([16399,16682,16403,16594],0); -ELEMENTS[50598] = Fluid3D([16682,16399,16531,16594],0); -ELEMENTS[50599] = Fluid3D([16399,16329,16531,15758],0); -ELEMENTS[50600] = Fluid3D([16682,16403,16594,17015],0); -ELEMENTS[50601] = Fluid3D([16399,16128,16329,15628],0); -ELEMENTS[50602] = Fluid3D([16144,16117,16585,16061],0); -ELEMENTS[50603] = Fluid3D([16117,16585,16061,16516],0); -ELEMENTS[50604] = Fluid3D([16144,16117,16061,15554],0); -ELEMENTS[50605] = Fluid3D([16061,16117,16516,15748],0); -ELEMENTS[50606] = Fluid3D([16061,16117,15748,15554],0); -ELEMENTS[50607] = Fluid3D([10725,9812,10271,10830],0); -ELEMENTS[50608] = Fluid3D([13875,13380,14065,13551],0); -ELEMENTS[50609] = Fluid3D([2086,2287,2213,2266],0); -ELEMENTS[50610] = Fluid3D([4008,4415,3874,4359],0); -ELEMENTS[50611] = Fluid3D([13815,14186,14831,14245],0); -ELEMENTS[50612] = Fluid3D([14186,14831,14245,14559],0); -ELEMENTS[50613] = Fluid3D([13815,14186,14245,13593],0); -ELEMENTS[50614] = Fluid3D([14186,14245,13593,14559],0); -ELEMENTS[50615] = Fluid3D([14245,13815,13593,14178],0); -ELEMENTS[50616] = Fluid3D([13593,14245,14178,14495],0); -ELEMENTS[50617] = Fluid3D([13593,14245,14495,14559],0); -ELEMENTS[50618] = Fluid3D([14245,13815,14178,14831],0); -ELEMENTS[50619] = Fluid3D([14245,14178,14495,14831],0); -ELEMENTS[50620] = Fluid3D([14495,14245,14831,14559],0); -ELEMENTS[50621] = Fluid3D([4844,5396,5402,5002],0); -ELEMENTS[50622] = Fluid3D([6491,5979,6132,6002],0); -ELEMENTS[50623] = Fluid3D([17083,17251,17428,16805],0); -ELEMENTS[50624] = Fluid3D([2705,2715,2564,2995],0); -ELEMENTS[50625] = Fluid3D([11607,12427,11159,10867],0); -ELEMENTS[50626] = Fluid3D([17181,17368,17639,17459],0); -ELEMENTS[50627] = Fluid3D([13226,13828,13098,13835],0); -ELEMENTS[50628] = Fluid3D([13226,13828,13835,13344],0); -ELEMENTS[50629] = Fluid3D([18528,18588,18444,18487],0); -ELEMENTS[50630] = Fluid3D([15510,15237,15526,15571],0); -ELEMENTS[50631] = Fluid3D([9317,10004,10402,10213],0); -ELEMENTS[50632] = Fluid3D([9317,10004,10213,10010],0); -ELEMENTS[50633] = Fluid3D([10004,10213,10010,11131],0); -ELEMENTS[50634] = Fluid3D([10004,10402,10213,11542],0); -ELEMENTS[50635] = Fluid3D([5030,5557,5267,5468],0); -ELEMENTS[50636] = Fluid3D([12873,12837,13722,13492],0); -ELEMENTS[50637] = Fluid3D([16075,15641,15851,15742],0); -ELEMENTS[50638] = Fluid3D([10096,9565,10245,9055],0); -ELEMENTS[50639] = Fluid3D([13817,14562,14435,13958],0); -ELEMENTS[50640] = Fluid3D([5898,5970,5809,6590],0); -ELEMENTS[50641] = Fluid3D([15526,15237,15138,15571],0); -ELEMENTS[50642] = Fluid3D([15237,15138,15571,15510],0); -ELEMENTS[50643] = Fluid3D([15350,15968,15580,15462],0); -ELEMENTS[50644] = Fluid3D([8926,8122,8452,8477],0); -ELEMENTS[50645] = Fluid3D([8122,8452,8477,7931],0); -ELEMENTS[50646] = Fluid3D([8122,8452,7931,7584],0); -ELEMENTS[50647] = Fluid3D([8477,8122,7931,7558],0); -ELEMENTS[50648] = Fluid3D([8122,7931,7558,7294],0); -ELEMENTS[50649] = Fluid3D([7931,7558,7294,7584],0); -ELEMENTS[50650] = Fluid3D([8122,7931,7294,7584],0); -ELEMENTS[50651] = Fluid3D([8452,7931,7584,7721],0); -ELEMENTS[50652] = Fluid3D([8452,8477,7931,8653],0); -ELEMENTS[50653] = Fluid3D([8452,8477,8653,9936],0); -ELEMENTS[50654] = Fluid3D([8477,7931,8653,7558],0); -ELEMENTS[50655] = Fluid3D([7931,8452,8653,8410],0); -ELEMENTS[50656] = Fluid3D([7931,7558,7584,7721],0); -ELEMENTS[50657] = Fluid3D([7931,7558,7721,8410],0); -ELEMENTS[50658] = Fluid3D([7721,7931,8410,8452],0); -ELEMENTS[50659] = Fluid3D([7558,7721,8410,8366],0); -ELEMENTS[50660] = Fluid3D([18576,18550,18636,18582],0); -ELEMENTS[50661] = Fluid3D([18550,18636,18582,18601],0); -ELEMENTS[50662] = Fluid3D([18582,18550,18601,18521],0); -ELEMENTS[50663] = Fluid3D([5256,5021,4734,5574],0); -ELEMENTS[50664] = Fluid3D([11395,12354,12658,11478],0); -ELEMENTS[50665] = Fluid3D([15797,15533,15625,15840],0); -ELEMENTS[50666] = Fluid3D([15533,15625,15840,14962],0); -ELEMENTS[50667] = Fluid3D([9755,9410,9567,10696],0); -ELEMENTS[50668] = Fluid3D([6923,6605,6810,7728],0); -ELEMENTS[50669] = Fluid3D([15717,15109,15506,15026],0); -ELEMENTS[50670] = Fluid3D([2720,2586,2423,2692],0); -ELEMENTS[50671] = Fluid3D([2423,2720,2692,2529],0); -ELEMENTS[50672] = Fluid3D([2747,2636,2846,3009],0); -ELEMENTS[50673] = Fluid3D([8364,8537,7969,9242],0); -ELEMENTS[50674] = Fluid3D([6018,5821,5838,5927],0); -ELEMENTS[50675] = Fluid3D([6018,5821,5927,6531],0); -ELEMENTS[50676] = Fluid3D([5821,5838,5927,5304],0); -ELEMENTS[50677] = Fluid3D([5927,5821,5304,5394],0); -ELEMENTS[50678] = Fluid3D([5927,5821,5394,5711],0); -ELEMENTS[50679] = Fluid3D([18203,18090,18356,18217],0); -ELEMENTS[50680] = Fluid3D([7041,7550,7555,8069],0); -ELEMENTS[50681] = Fluid3D([13698,14029,13113,13612],0); -ELEMENTS[50682] = Fluid3D([12205,12764,11519,12060],0); -ELEMENTS[50683] = Fluid3D([11519,12205,12060,11890],0); -ELEMENTS[50684] = Fluid3D([12205,12060,11890,12764],0); -ELEMENTS[50685] = Fluid3D([11519,12205,11890,11708],0); -ELEMENTS[50686] = Fluid3D([12060,11519,11890,11197],0); -ELEMENTS[50687] = Fluid3D([11890,12060,11197,12200],0); -ELEMENTS[50688] = Fluid3D([12060,11197,12200,12283],0); -ELEMENTS[50689] = Fluid3D([11890,12060,12200,12823],0); -ELEMENTS[50690] = Fluid3D([11890,12060,12823,12764],0); -ELEMENTS[50691] = Fluid3D([12060,12200,12823,13012],0); -ELEMENTS[50692] = Fluid3D([12060,12823,12764,13012],0); -ELEMENTS[50693] = Fluid3D([12200,12060,12283,13012],0); -ELEMENTS[50694] = Fluid3D([14422,13769,13578,13610],0); -ELEMENTS[50695] = Fluid3D([13769,13578,13610,12934],0); -ELEMENTS[50696] = Fluid3D([13769,13578,12934,13219],0); -ELEMENTS[50697] = Fluid3D([13769,13578,13219,13999],0); -ELEMENTS[50698] = Fluid3D([13578,12934,13219,12741],0); -ELEMENTS[50699] = Fluid3D([13578,12934,12741,13005],0); -ELEMENTS[50700] = Fluid3D([12741,13578,13005,12674],0); -ELEMENTS[50701] = Fluid3D([13219,13578,12741,12674],0); -ELEMENTS[50702] = Fluid3D([13005,12741,12674,12047],0); -ELEMENTS[50703] = Fluid3D([12741,12674,12047,13219],0); -ELEMENTS[50704] = Fluid3D([13005,12741,12047,12414],0); -ELEMENTS[50705] = Fluid3D([12934,13769,13219,12808],0); -ELEMENTS[50706] = Fluid3D([12934,13219,12741,12047],0); -ELEMENTS[50707] = Fluid3D([12934,12741,13005,12414],0); -ELEMENTS[50708] = Fluid3D([12934,12741,12414,12047],0); -ELEMENTS[50709] = Fluid3D([13578,13610,12934,13005],0); -ELEMENTS[50710] = Fluid3D([13610,13769,12934,13630],0); -ELEMENTS[50711] = Fluid3D([5543,5507,6273,5562],0); -ELEMENTS[50712] = Fluid3D([4439,4262,4098,3871],0); -ELEMENTS[50713] = Fluid3D([5244,5088,4742,5612],0); -ELEMENTS[50714] = Fluid3D([17969,17783,18126,18167],0); -ELEMENTS[50715] = Fluid3D([15590,15013,14948,14839],0); -ELEMENTS[50716] = Fluid3D([6229,5625,5531,5863],0); -ELEMENTS[50717] = Fluid3D([9913,9744,8925,9396],0); -ELEMENTS[50718] = Fluid3D([9368,9856,10366,10346],0); -ELEMENTS[50719] = Fluid3D([9368,9856,10346,9097],0); -ELEMENTS[50720] = Fluid3D([15076,14821,15524,15580],0); -ELEMENTS[50721] = Fluid3D([15646,15392,15785,15009],0); -ELEMENTS[50722] = Fluid3D([9174,9126,8815,9665],0); -ELEMENTS[50723] = Fluid3D([13369,13894,13453,14601],0); -ELEMENTS[50724] = Fluid3D([15588,15524,15076,15347],0); -ELEMENTS[50725] = Fluid3D([6184,5824,5847,6185],0); -ELEMENTS[50726] = Fluid3D([15976,15899,15308,15398],0); -ELEMENTS[50727] = Fluid3D([2637,2566,2464,2602],0); -ELEMENTS[50728] = Fluid3D([16947,16883,17342,17160],0); -ELEMENTS[50729] = Fluid3D([12649,12231,12131,12203],0); -ELEMENTS[50730] = Fluid3D([10062,10224,10212,9574],0); -ELEMENTS[50731] = Fluid3D([14120,14406,13827,14699],0); -ELEMENTS[50732] = Fluid3D([8657,8414,9509,9285],0); -ELEMENTS[50733] = Fluid3D([9509,8657,9285,9393],0); -ELEMENTS[50734] = Fluid3D([7200,6893,7698,6862],0); -ELEMENTS[50735] = Fluid3D([2889,2694,3025,2936],0); -ELEMENTS[50736] = Fluid3D([16727,16505,16541,17020],0); -ELEMENTS[50737] = Fluid3D([4165,3932,4060,3818],0); -ELEMENTS[50738] = Fluid3D([4060,4165,3818,4284],0); -ELEMENTS[50739] = Fluid3D([4165,3818,4284,4027],0); -ELEMENTS[50740] = Fluid3D([8084,7888,7991,6968],0); -ELEMENTS[50741] = Fluid3D([12843,12474,13633,12876],0); -ELEMENTS[50742] = Fluid3D([9837,10398,10791,10940],0); -ELEMENTS[50743] = Fluid3D([10398,10791,10940,11821],0); -ELEMENTS[50744] = Fluid3D([17283,17163,17320,16898],0); -ELEMENTS[50745] = Fluid3D([17139,17196,16913,16625],0); -ELEMENTS[50746] = Fluid3D([5885,5360,5926,5756],0); -ELEMENTS[50747] = Fluid3D([4963,4410,4890,4998],0); -ELEMENTS[50748] = Fluid3D([13254,13984,13605,12974],0); -ELEMENTS[50749] = Fluid3D([13605,13254,12974,13130],0); -ELEMENTS[50750] = Fluid3D([13605,13254,13130,13909],0); -ELEMENTS[50751] = Fluid3D([13130,13605,13909,12974],0); -ELEMENTS[50752] = Fluid3D([13605,13909,12974,13735],0); -ELEMENTS[50753] = Fluid3D([12974,13605,13735,13984],0); -ELEMENTS[50754] = Fluid3D([13605,13909,13735,14352],0); -ELEMENTS[50755] = Fluid3D([13605,13909,14352,13984],0); -ELEMENTS[50756] = Fluid3D([13735,13605,14352,13984],0); -ELEMENTS[50757] = Fluid3D([13909,13735,14352,14662],0); -ELEMENTS[50758] = Fluid3D([14352,13909,14662,14536],0); -ELEMENTS[50759] = Fluid3D([14352,13909,14536,13984],0); -ELEMENTS[50760] = Fluid3D([14536,14352,13984,14767],0); -ELEMENTS[50761] = Fluid3D([14536,14352,14767,14662],0); -ELEMENTS[50762] = Fluid3D([14352,13984,14767,13735],0); -ELEMENTS[50763] = Fluid3D([14352,14767,14662,13735],0); -ELEMENTS[50764] = Fluid3D([8477,8386,7821,7558],0); -ELEMENTS[50765] = Fluid3D([17012,16757,16680,17241],0); -ELEMENTS[50766] = Fluid3D([9994,11254,10709,10238],0); -ELEMENTS[50767] = Fluid3D([13069,13730,13366,12546],0); -ELEMENTS[50768] = Fluid3D([7141,7278,7750,7514],0); -ELEMENTS[50769] = Fluid3D([7278,7750,7514,7082],0); -ELEMENTS[50770] = Fluid3D([7278,7750,7082,8302],0); -ELEMENTS[50771] = Fluid3D([16513,16609,16834,16246],0); -ELEMENTS[50772] = Fluid3D([15704,16255,15737,15736],0); -ELEMENTS[50773] = Fluid3D([5854,5318,5512,5929],0); -ELEMENTS[50774] = Fluid3D([18480,18431,18510,18603],0); -ELEMENTS[50775] = Fluid3D([17200,17129,17043,16687],0); -ELEMENTS[50776] = Fluid3D([2539,2799,2778,2503],0); -ELEMENTS[50777] = Fluid3D([14761,15209,14621,14298],0); -ELEMENTS[50778] = Fluid3D([16936,17026,16857,17242],0); -ELEMENTS[50779] = Fluid3D([16857,16936,17242,17296],0); -ELEMENTS[50780] = Fluid3D([16936,17026,17242,17391],0); -ELEMENTS[50781] = Fluid3D([17242,16936,17391,17296],0); -ELEMENTS[50782] = Fluid3D([17391,17242,17296,17674],0); -ELEMENTS[50783] = Fluid3D([17391,17242,17674,17570],0); -ELEMENTS[50784] = Fluid3D([17242,16857,17296,17322],0); -ELEMENTS[50785] = Fluid3D([4810,4976,4827,4286],0); -ELEMENTS[50786] = Fluid3D([3563,3503,3226,3604],0); -ELEMENTS[50787] = Fluid3D([3221,3488,3440,3760],0); -ELEMENTS[50788] = Fluid3D([7509,7605,6771,7318],0); -ELEMENTS[50789] = Fluid3D([17475,17586,17592,17912],0); -ELEMENTS[50790] = Fluid3D([2569,2680,2385,2696],0); -ELEMENTS[50791] = Fluid3D([2569,2680,2696,2963],0); -ELEMENTS[50792] = Fluid3D([2385,2569,2696,2750],0); -ELEMENTS[50793] = Fluid3D([2569,2696,2750,2963],0); -ELEMENTS[50794] = Fluid3D([2696,2750,2963,2614],0); -ELEMENTS[50795] = Fluid3D([2696,2750,2614,2385],0); -ELEMENTS[50796] = Fluid3D([2963,2696,2614,2572],0); -ELEMENTS[50797] = Fluid3D([2696,2614,2572,2385],0); -ELEMENTS[50798] = Fluid3D([2680,2696,2963,2572],0); -ELEMENTS[50799] = Fluid3D([18413,18550,18582,18521],0); -ELEMENTS[50800] = Fluid3D([7493,7185,6908,6590],0); -ELEMENTS[50801] = Fluid3D([6908,7493,6590,6875],0); -ELEMENTS[50802] = Fluid3D([3897,3906,3832,3502],0); -ELEMENTS[50803] = Fluid3D([3832,3897,3502,3384],0); -ELEMENTS[50804] = Fluid3D([3502,3832,3384,3428],0); -ELEMENTS[50805] = Fluid3D([3384,3502,3428,3011],0); -ELEMENTS[50806] = Fluid3D([3502,3832,3428,3906],0); -ELEMENTS[50807] = Fluid3D([3897,3906,3502,3458],0); -ELEMENTS[50808] = Fluid3D([6017,6777,6729,6311],0); -ELEMENTS[50809] = Fluid3D([6017,6777,6311,6961],0); -ELEMENTS[50810] = Fluid3D([3796,4133,4027,3853],0); -ELEMENTS[50811] = Fluid3D([3796,4133,3853,3763],0); -ELEMENTS[50812] = Fluid3D([3796,4133,3763,3589],0); -ELEMENTS[50813] = Fluid3D([3853,3796,3763,3393],0); -ELEMENTS[50814] = Fluid3D([3763,3796,3589,3393],0); -ELEMENTS[50815] = Fluid3D([3589,3763,3393,3356],0); -ELEMENTS[50816] = Fluid3D([4133,3853,3763,4441],0); -ELEMENTS[50817] = Fluid3D([4027,3796,3853,3593],0); -ELEMENTS[50818] = Fluid3D([3796,3853,3593,3393],0); -ELEMENTS[50819] = Fluid3D([3853,4027,3593,3818],0); -ELEMENTS[50820] = Fluid3D([3853,3593,3393,3460],0); -ELEMENTS[50821] = Fluid3D([3763,3853,3393,3460],0); -ELEMENTS[50822] = Fluid3D([6905,7234,7288,7882],0); -ELEMENTS[50823] = Fluid3D([11049,11642,10732,11446],0); -ELEMENTS[50824] = Fluid3D([11049,11642,11446,12380],0); -ELEMENTS[50825] = Fluid3D([11642,10732,11446,11563],0); -ELEMENTS[50826] = Fluid3D([11446,11642,11563,12439],0); -ELEMENTS[50827] = Fluid3D([11446,11642,12439,12380],0); -ELEMENTS[50828] = Fluid3D([11563,11446,12439,12025],0); -ELEMENTS[50829] = Fluid3D([10732,11446,11563,10619],0); -ELEMENTS[50830] = Fluid3D([11446,11563,10619,12025],0); -ELEMENTS[50831] = Fluid3D([17571,17772,17871,17870],0); -ELEMENTS[50832] = Fluid3D([17571,17772,17870,17644],0); -ELEMENTS[50833] = Fluid3D([17772,17870,17644,18046],0); -ELEMENTS[50834] = Fluid3D([4327,4258,4052,4044],0); -ELEMENTS[50835] = Fluid3D([15642,15720,16254,16145],0); -ELEMENTS[50836] = Fluid3D([16015,16319,16123,15543],0); -ELEMENTS[50837] = Fluid3D([17730,17849,18070,17682],0); -ELEMENTS[50838] = Fluid3D([17730,17849,17682,17407],0); -ELEMENTS[50839] = Fluid3D([3974,3712,3977,4259],0); -ELEMENTS[50840] = Fluid3D([14386,13533,14146,13694],0); -ELEMENTS[50841] = Fluid3D([9923,10258,9958,11168],0); -ELEMENTS[50842] = Fluid3D([7786,7111,7244,6690],0); -ELEMENTS[50843] = Fluid3D([7786,7111,6690,7471],0); -ELEMENTS[50844] = Fluid3D([7111,7244,6690,6982],0); -ELEMENTS[50845] = Fluid3D([6690,7111,6982,6910],0); -ELEMENTS[50846] = Fluid3D([6614,6159,5865,6296],0); -ELEMENTS[50847] = Fluid3D([12306,12384,12465,12836],0); -ELEMENTS[50848] = Fluid3D([12465,12306,12836,12323],0); -ELEMENTS[50849] = Fluid3D([12306,12836,12323,12985],0); -ELEMENTS[50850] = Fluid3D([12306,12384,12836,12522],0); -ELEMENTS[50851] = Fluid3D([12306,12384,12522,11704],0); -ELEMENTS[50852] = Fluid3D([12522,12306,11704,12365],0); -ELEMENTS[50853] = Fluid3D([12522,12306,12365,12985],0); -ELEMENTS[50854] = Fluid3D([12836,12306,12522,12985],0); -ELEMENTS[50855] = Fluid3D([11704,12522,12365,12161],0); -ELEMENTS[50856] = Fluid3D([12384,12522,11704,12783],0); -ELEMENTS[50857] = Fluid3D([3808,3988,4268,4204],0); -ELEMENTS[50858] = Fluid3D([4268,3808,4204,3783],0); -ELEMENTS[50859] = Fluid3D([4268,3808,3783,3692],0); -ELEMENTS[50860] = Fluid3D([3808,4204,3783,3801],0); -ELEMENTS[50861] = Fluid3D([3783,3808,3801,3369],0); -ELEMENTS[50862] = Fluid3D([13698,14251,14029,13612],0); -ELEMENTS[50863] = Fluid3D([7196,7264,7635,7971],0); -ELEMENTS[50864] = Fluid3D([7196,7264,7971,6994],0); -ELEMENTS[50865] = Fluid3D([7635,7196,7971,8289],0); -ELEMENTS[50866] = Fluid3D([7635,7196,8289,7590],0); -ELEMENTS[50867] = Fluid3D([7635,7196,7590,6889],0); -ELEMENTS[50868] = Fluid3D([7196,7590,6889,8289],0); -ELEMENTS[50869] = Fluid3D([8289,7635,7590,7882],0); -ELEMENTS[50870] = Fluid3D([7590,7635,6889,6976],0); -ELEMENTS[50871] = Fluid3D([6889,7590,6976,7882],0); -ELEMENTS[50872] = Fluid3D([7590,7635,6976,7882],0); -ELEMENTS[50873] = Fluid3D([7635,7196,6889,6976],0); -ELEMENTS[50874] = Fluid3D([13664,13741,13276,12658],0); -ELEMENTS[50875] = Fluid3D([6298,6516,6527,5704],0); -ELEMENTS[50876] = Fluid3D([14413,14354,13888,13784],0); -ELEMENTS[50877] = Fluid3D([10560,11184,11308,11821],0); -ELEMENTS[50878] = Fluid3D([8596,7998,8312,8861],0); -ELEMENTS[50879] = Fluid3D([17575,17528,17697,17309],0); -ELEMENTS[50880] = Fluid3D([18445,18416,18449,18539],0); -ELEMENTS[50881] = Fluid3D([18449,18445,18539,18467],0); -ELEMENTS[50882] = Fluid3D([18449,18445,18467,18341],0); -ELEMENTS[50883] = Fluid3D([16436,16861,16933,16888],0); -ELEMENTS[50884] = Fluid3D([1997,1956,2083,2185],0); -ELEMENTS[50885] = Fluid3D([1956,2083,2185,2098],0); -ELEMENTS[50886] = Fluid3D([9237,10223,9547,9275],0); -ELEMENTS[50887] = Fluid3D([9547,9237,9275,8630],0); -ELEMENTS[50888] = Fluid3D([9237,10223,9275,9981],0); -ELEMENTS[50889] = Fluid3D([11098,10905,10386,10782],0); -ELEMENTS[50890] = Fluid3D([11773,11886,11185,10853],0); -ELEMENTS[50891] = Fluid3D([17700,17808,17627,17383],0); -ELEMENTS[50892] = Fluid3D([10820,11782,11755,12040],0); -ELEMENTS[50893] = Fluid3D([11782,11755,12040,12585],0); -ELEMENTS[50894] = Fluid3D([11782,11755,12585,12222],0); -ELEMENTS[50895] = Fluid3D([12040,11782,12585,12933],0); -ELEMENTS[50896] = Fluid3D([11755,12040,12585,12633],0); -ELEMENTS[50897] = Fluid3D([12585,12040,12933,13320],0); -ELEMENTS[50898] = Fluid3D([12933,12585,13320,13123],0); -ELEMENTS[50899] = Fluid3D([11782,12585,12933,12910],0); -ELEMENTS[50900] = Fluid3D([12585,12933,12910,13123],0); -ELEMENTS[50901] = Fluid3D([12040,11782,12933,11560],0); -ELEMENTS[50902] = Fluid3D([6589,6956,6543,6892],0); -ELEMENTS[50903] = Fluid3D([8298,8954,8551,7722],0); -ELEMENTS[50904] = Fluid3D([16158,16676,16721,16503],0); -ELEMENTS[50905] = Fluid3D([14598,13992,14723,14116],0); -ELEMENTS[50906] = Fluid3D([7461,7649,7171,6860],0); -ELEMENTS[50907] = Fluid3D([7461,7649,6860,7376],0); -ELEMENTS[50908] = Fluid3D([7649,7171,6860,7608],0); -ELEMENTS[50909] = Fluid3D([6860,7649,7608,7376],0); -ELEMENTS[50910] = Fluid3D([1740,1802,1644,1739],0); -ELEMENTS[50911] = Fluid3D([17328,16793,16991,17408],0); -ELEMENTS[50912] = Fluid3D([8815,8306,9374,9477],0); -ELEMENTS[50913] = Fluid3D([3918,3943,3544,3917],0); -ELEMENTS[50914] = Fluid3D([3943,3544,3917,3734],0); -ELEMENTS[50915] = Fluid3D([3917,3943,3734,4186],0); -ELEMENTS[50916] = Fluid3D([6441,6019,6334,6574],0); -ELEMENTS[50917] = Fluid3D([9129,8284,8206,8426],0); -ELEMENTS[50918] = Fluid3D([18139,17856,18048,18015],0); -ELEMENTS[50919] = Fluid3D([7508,6756,7374,7611],0); -ELEMENTS[50920] = Fluid3D([4926,4433,4756,4911],0); -ELEMENTS[50921] = Fluid3D([17377,17666,17766,17510],0); -ELEMENTS[50922] = Fluid3D([15671,15776,15026,15717],0); -ELEMENTS[50923] = Fluid3D([15671,15776,15717,16413],0); -ELEMENTS[50924] = Fluid3D([10788,10634,10241,9858],0); -ELEMENTS[50925] = Fluid3D([10788,10634,9858,10604],0); -ELEMENTS[50926] = Fluid3D([10788,10634,10604,11656],0); -ELEMENTS[50927] = Fluid3D([10939,11043,11814,11984],0); -ELEMENTS[50928] = Fluid3D([10142,9704,10612,10638],0); -ELEMENTS[50929] = Fluid3D([9704,10612,10638,10043],0); -ELEMENTS[50930] = Fluid3D([8321,7505,7487,8067],0); -ELEMENTS[50931] = Fluid3D([5750,5583,5757,6013],0); -ELEMENTS[50932] = Fluid3D([5750,5583,6013,6134],0); -ELEMENTS[50933] = Fluid3D([12267,12410,13279,12949],0); -ELEMENTS[50934] = Fluid3D([6292,6993,6766,6131],0); -ELEMENTS[50935] = Fluid3D([4017,3688,3829,3515],0); -ELEMENTS[50936] = Fluid3D([8820,8783,7972,8455],0); -ELEMENTS[50937] = Fluid3D([17185,16756,16936,16548],0); -ELEMENTS[50938] = Fluid3D([6020,5764,6005,6879],0); -ELEMENTS[50939] = Fluid3D([8312,7624,8199,7379],0); -ELEMENTS[50940] = Fluid3D([8199,8312,7379,7998],0); -ELEMENTS[50941] = Fluid3D([8199,8312,7998,8861],0); -ELEMENTS[50942] = Fluid3D([4105,3863,3662,4318],0); -ELEMENTS[50943] = Fluid3D([2961,3347,3155,3069],0); -ELEMENTS[50944] = Fluid3D([18308,18361,18154,18137],0); -ELEMENTS[50945] = Fluid3D([3511,3385,3144,3751],0); -ELEMENTS[50946] = Fluid3D([3511,3385,3751,4040],0); -ELEMENTS[50947] = Fluid3D([13847,14158,14416,14594],0); -ELEMENTS[50948] = Fluid3D([13847,14158,14594,14094],0); -ELEMENTS[50949] = Fluid3D([13847,14158,14094,12884],0); -ELEMENTS[50950] = Fluid3D([1928,1975,2086,1804],0); -ELEMENTS[50951] = Fluid3D([1928,1975,1804,1816],0); -ELEMENTS[50952] = Fluid3D([11057,11475,10429,10553],0); -ELEMENTS[50953] = Fluid3D([18155,18357,18393,18305],0); -ELEMENTS[50954] = Fluid3D([9375,8798,9658,8866],0); -ELEMENTS[50955] = Fluid3D([4226,3941,3934,3622],0); -ELEMENTS[50956] = Fluid3D([13640,12590,13520,13574],0); -ELEMENTS[50957] = Fluid3D([6956,6321,6543,6442],0); -ELEMENTS[50958] = Fluid3D([9011,8699,9091,7983],0); -ELEMENTS[50959] = Fluid3D([14773,14095,14847,14710],0); -ELEMENTS[50960] = Fluid3D([16563,16199,16454,15943],0); -ELEMENTS[50961] = Fluid3D([14848,14910,14961,15458],0); -ELEMENTS[50962] = Fluid3D([16937,17230,16927,17093],0); -ELEMENTS[50963] = Fluid3D([9468,9993,10594,10002],0); -ELEMENTS[50964] = Fluid3D([12492,12705,12847,13505],0); -ELEMENTS[50965] = Fluid3D([12492,12705,13505,13125],0); -ELEMENTS[50966] = Fluid3D([5016,5240,5079,5176],0); -ELEMENTS[50967] = Fluid3D([5240,5079,5176,5686],0); -ELEMENTS[50968] = Fluid3D([5016,5240,5176,5686],0); -ELEMENTS[50969] = Fluid3D([5176,5016,5686,5481],0); -ELEMENTS[50970] = Fluid3D([6613,7269,7168,6907],0); -ELEMENTS[50971] = Fluid3D([7168,6613,6907,6385],0); -ELEMENTS[50972] = Fluid3D([7168,6613,6385,6345],0); -ELEMENTS[50973] = Fluid3D([6613,6907,6385,6019],0); -ELEMENTS[50974] = Fluid3D([7168,6613,6345,6646],0); -ELEMENTS[50975] = Fluid3D([6298,6664,6516,5985],0); -ELEMENTS[50976] = Fluid3D([6664,6516,5985,6689],0); -ELEMENTS[50977] = Fluid3D([10402,9317,10213,9942],0); -ELEMENTS[50978] = Fluid3D([9317,10213,9942,9682],0); -ELEMENTS[50979] = Fluid3D([10213,10402,9942,10705],0); -ELEMENTS[50980] = Fluid3D([9942,10213,10705,9682],0); -ELEMENTS[50981] = Fluid3D([10213,10402,10705,11542],0); -ELEMENTS[50982] = Fluid3D([10402,9317,9942,9484],0); -ELEMENTS[50983] = Fluid3D([6250,6217,5885,5542],0); -ELEMENTS[50984] = Fluid3D([3157,2885,3222,2750],0); -ELEMENTS[50985] = Fluid3D([15886,16314,16244,15990],0); -ELEMENTS[50986] = Fluid3D([14594,14798,15380,15177],0); -ELEMENTS[50987] = Fluid3D([1831,1723,1717,1728],0); -ELEMENTS[50988] = Fluid3D([1831,1723,1728,1727],0); -ELEMENTS[50989] = Fluid3D([1717,1831,1728,1832],0); -ELEMENTS[50990] = Fluid3D([1831,1728,1832,1848],0); -ELEMENTS[50991] = Fluid3D([5217,5188,4747,5205],0); -ELEMENTS[50992] = Fluid3D([2816,2529,2806,2863],0); -ELEMENTS[50993] = Fluid3D([7237,7352,8117,7535],0); -ELEMENTS[50994] = Fluid3D([7352,8117,7535,7357],0); -ELEMENTS[50995] = Fluid3D([7535,7352,7357,6829],0); -ELEMENTS[50996] = Fluid3D([7535,7352,6829,7237],0); -ELEMENTS[50997] = Fluid3D([7357,7535,6829,7305],0); -ELEMENTS[50998] = Fluid3D([7535,6829,7305,7673],0); -ELEMENTS[50999] = Fluid3D([7535,6829,7673,7237],0); -ELEMENTS[51000] = Fluid3D([7305,7535,7673,8203],0); -ELEMENTS[51001] = Fluid3D([7535,7673,8203,7237],0); -ELEMENTS[51002] = Fluid3D([7352,6829,7237,6417],0); -ELEMENTS[51003] = Fluid3D([7673,7305,8203,8145],0); -ELEMENTS[51004] = Fluid3D([7305,7535,8203,7357],0); -ELEMENTS[51005] = Fluid3D([7535,8203,7357,8117],0); -ELEMENTS[51006] = Fluid3D([7535,8203,8117,7237],0); -ELEMENTS[51007] = Fluid3D([16595,16805,16485,16973],0); -ELEMENTS[51008] = Fluid3D([16595,16805,16973,17224],0); -ELEMENTS[51009] = Fluid3D([16485,16595,16973,16542],0); -ELEMENTS[51010] = Fluid3D([16805,16485,16973,16767],0); -ELEMENTS[51011] = Fluid3D([12624,12766,11866,12499],0); -ELEMENTS[51012] = Fluid3D([16235,15754,15760,15876],0); -ELEMENTS[51013] = Fluid3D([10964,11087,10289,10544],0); -ELEMENTS[51014] = Fluid3D([12747,13659,13859,13102],0); -ELEMENTS[51015] = Fluid3D([13659,13859,13102,13968],0); -ELEMENTS[51016] = Fluid3D([13659,13859,13968,14367],0); -ELEMENTS[51017] = Fluid3D([13659,13859,14367,14317],0); -ELEMENTS[51018] = Fluid3D([13859,13968,14367,14813],0); -ELEMENTS[51019] = Fluid3D([13968,13659,14367,14369],0); -ELEMENTS[51020] = Fluid3D([14367,13859,14813,14551],0); -ELEMENTS[51021] = Fluid3D([13859,14367,14317,14551],0); -ELEMENTS[51022] = Fluid3D([13859,13102,13968,14304],0); -ELEMENTS[51023] = Fluid3D([13968,13859,14304,14813],0); -ELEMENTS[51024] = Fluid3D([13968,14367,14813,14304],0); -ELEMENTS[51025] = Fluid3D([13968,14367,14304,14369],0); -ELEMENTS[51026] = Fluid3D([14304,13968,14369,13790],0); -ELEMENTS[51027] = Fluid3D([14304,13968,13790,13102],0); -ELEMENTS[51028] = Fluid3D([14367,13659,14317,14609],0); -ELEMENTS[51029] = Fluid3D([14317,14367,14609,14813],0); -ELEMENTS[51030] = Fluid3D([14367,14609,14813,15078],0); -ELEMENTS[51031] = Fluid3D([14317,14367,14813,14551],0); -ELEMENTS[51032] = Fluid3D([14367,13659,14609,14369],0); -ELEMENTS[51033] = Fluid3D([14367,14609,15078,14369],0); -ELEMENTS[51034] = Fluid3D([14813,14367,15078,14304],0); -ELEMENTS[51035] = Fluid3D([13968,14369,13790,13659],0); -ELEMENTS[51036] = Fluid3D([13103,13545,12681,13366],0); -ELEMENTS[51037] = Fluid3D([14222,13818,14604,14996],0); -ELEMENTS[51038] = Fluid3D([14013,13873,13414,14134],0); -ELEMENTS[51039] = Fluid3D([13414,14013,14134,13401],0); -ELEMENTS[51040] = Fluid3D([9288,9036,8491,9039],0); -ELEMENTS[51041] = Fluid3D([15011,14707,14603,15343],0); -ELEMENTS[51042] = Fluid3D([3233,2884,3014,3340],0); -ELEMENTS[51043] = Fluid3D([6977,6587,6742,6044],0); -ELEMENTS[51044] = Fluid3D([2215,2398,2174,2394],0); -ELEMENTS[51045] = Fluid3D([18599,18600,18474,18639],0); -ELEMENTS[51046] = Fluid3D([13268,13554,13698,12645],0); -ELEMENTS[51047] = Fluid3D([13698,13268,12645,12719],0); -ELEMENTS[51048] = Fluid3D([14714,14969,15098,15186],0); -ELEMENTS[51049] = Fluid3D([7420,6669,7842,7921],0); -ELEMENTS[51050] = Fluid3D([7842,7420,7921,7815],0); -ELEMENTS[51051] = Fluid3D([7842,7420,7815,8469],0); -ELEMENTS[51052] = Fluid3D([10903,10116,10429,10211],0); -ELEMENTS[51053] = Fluid3D([10903,10116,10211,10673],0); -ELEMENTS[51054] = Fluid3D([10211,10903,10673,10399],0); -ELEMENTS[51055] = Fluid3D([10673,10211,10399,9529],0); -ELEMENTS[51056] = Fluid3D([10211,10903,10399,10553],0); -ELEMENTS[51057] = Fluid3D([10399,10211,10553,9572],0); -ELEMENTS[51058] = Fluid3D([10211,10903,10553,10429],0); -ELEMENTS[51059] = Fluid3D([10211,10553,9572,10429],0); -ELEMENTS[51060] = Fluid3D([12717,12972,13204,12019],0); -ELEMENTS[51061] = Fluid3D([18182,18398,18404,18222],0); -ELEMENTS[51062] = Fluid3D([18182,18398,18222,18324],0); -ELEMENTS[51063] = Fluid3D([18404,18182,18222,18255],0); -ELEMENTS[51064] = Fluid3D([13359,14201,13399,13222],0); -ELEMENTS[51065] = Fluid3D([13359,14201,13222,13508],0); -ELEMENTS[51066] = Fluid3D([13222,13359,13508,12688],0); -ELEMENTS[51067] = Fluid3D([13222,13359,12688,12149],0); -ELEMENTS[51068] = Fluid3D([13399,13359,13222,12149],0); -ELEMENTS[51069] = Fluid3D([13359,13508,12688,13746],0); -ELEMENTS[51070] = Fluid3D([13359,13508,13746,14201],0); -ELEMENTS[51071] = Fluid3D([12688,13359,13746,12787],0); -ELEMENTS[51072] = Fluid3D([13359,12688,12149,12770],0); -ELEMENTS[51073] = Fluid3D([13359,12688,12770,12787],0); -ELEMENTS[51074] = Fluid3D([9046,9827,9131,8970],0); -ELEMENTS[51075] = Fluid3D([17320,17593,17123,17640],0); -ELEMENTS[51076] = Fluid3D([4094,4221,4451,4610],0); -ELEMENTS[51077] = Fluid3D([12712,12875,12343,13275],0); -ELEMENTS[51078] = Fluid3D([15116,14701,14713,15463],0); -ELEMENTS[51079] = Fluid3D([18366,18477,18202,18298],0); -ELEMENTS[51080] = Fluid3D([18202,18366,18298,18424],0); -ELEMENTS[51081] = Fluid3D([18202,18366,18424,18286],0); -ELEMENTS[51082] = Fluid3D([18366,18298,18424,18531],0); -ELEMENTS[51083] = Fluid3D([18424,18366,18531,18515],0); -ELEMENTS[51084] = Fluid3D([18424,18366,18515,18406],0); -ELEMENTS[51085] = Fluid3D([18424,18366,18406,18286],0); -ELEMENTS[51086] = Fluid3D([18366,18515,18406,18281],0); -ELEMENTS[51087] = Fluid3D([18406,18366,18281,18253],0); -ELEMENTS[51088] = Fluid3D([18281,18406,18253,18265],0); -ELEMENTS[51089] = Fluid3D([18366,18281,18253,18135],0); -ELEMENTS[51090] = Fluid3D([18281,18253,18135,18194],0); -ELEMENTS[51091] = Fluid3D([18253,18135,18194,18265],0); -ELEMENTS[51092] = Fluid3D([18194,18253,18265,18281],0); -ELEMENTS[51093] = Fluid3D([18406,18366,18253,18286],0); -ELEMENTS[51094] = Fluid3D([18253,18406,18286,18265],0); -ELEMENTS[51095] = Fluid3D([18135,18194,18265,18058],0); -ELEMENTS[51096] = Fluid3D([18194,18265,18058,18254],0); -ELEMENTS[51097] = Fluid3D([18135,18194,18058,18281],0); -ELEMENTS[51098] = Fluid3D([18194,18058,18281,18254],0); -ELEMENTS[51099] = Fluid3D([18253,18366,18135,18286],0); -ELEMENTS[51100] = Fluid3D([18135,18253,18286,18265],0); -ELEMENTS[51101] = Fluid3D([18265,18194,18281,18254],0); -ELEMENTS[51102] = Fluid3D([18301,18441,18192,18379],0); -ELEMENTS[51103] = Fluid3D([13912,13403,13083,13688],0); -ELEMENTS[51104] = Fluid3D([13929,14672,14592,14809],0); -ELEMENTS[51105] = Fluid3D([9052,9503,8913,9485],0); -ELEMENTS[51106] = Fluid3D([9503,8913,9485,9648],0); -ELEMENTS[51107] = Fluid3D([9052,9503,9485,10515],0); -ELEMENTS[51108] = Fluid3D([13295,13118,13051,14023],0); -ELEMENTS[51109] = Fluid3D([13116,12404,13138,13502],0); -ELEMENTS[51110] = Fluid3D([12404,13138,13502,13618],0); -ELEMENTS[51111] = Fluid3D([13116,12404,13502,13013],0); -ELEMENTS[51112] = Fluid3D([12404,13502,13013,12839],0); -ELEMENTS[51113] = Fluid3D([13013,12404,12839,12676],0); -ELEMENTS[51114] = Fluid3D([12839,13013,12676,13450],0); -ELEMENTS[51115] = Fluid3D([13013,12676,13450,13381],0); -ELEMENTS[51116] = Fluid3D([12839,13013,13450,13502],0); -ELEMENTS[51117] = Fluid3D([13013,12676,13381,13116],0); -ELEMENTS[51118] = Fluid3D([13450,13013,13381,13116],0); -ELEMENTS[51119] = Fluid3D([13013,13450,13502,13116],0); -ELEMENTS[51120] = Fluid3D([12676,13450,13381,14056],0); -ELEMENTS[51121] = Fluid3D([12676,12839,13450,13312],0); -ELEMENTS[51122] = Fluid3D([12839,13450,13312,13618],0); -ELEMENTS[51123] = Fluid3D([13116,12404,13013,12676],0); -ELEMENTS[51124] = Fluid3D([13450,13381,14056,13838],0); -ELEMENTS[51125] = Fluid3D([13450,13381,13838,13116],0); -ELEMENTS[51126] = Fluid3D([14056,13450,13838,13562],0); -ELEMENTS[51127] = Fluid3D([13450,13838,13562,13312],0); -ELEMENTS[51128] = Fluid3D([13450,13838,13312,13618],0); -ELEMENTS[51129] = Fluid3D([13562,13450,13312,12676],0); -ELEMENTS[51130] = Fluid3D([13562,13450,12676,14056],0); -ELEMENTS[51131] = Fluid3D([13450,13838,13618,13502],0); -ELEMENTS[51132] = Fluid3D([13450,13838,13502,13116],0); -ELEMENTS[51133] = Fluid3D([13838,13618,13502,14124],0); -ELEMENTS[51134] = Fluid3D([13618,13502,14124,13918],0); -ELEMENTS[51135] = Fluid3D([13502,13838,14124,13116],0); -ELEMENTS[51136] = Fluid3D([13618,13502,13918,13138],0); -ELEMENTS[51137] = Fluid3D([13618,13450,13502,12839],0); -ELEMENTS[51138] = Fluid3D([13502,13618,12839,12404],0); -ELEMENTS[51139] = Fluid3D([13381,14056,13838,14323],0); -ELEMENTS[51140] = Fluid3D([14874,15282,15151,15546],0); -ELEMENTS[51141] = Fluid3D([15707,16177,15954,15757],0); -ELEMENTS[51142] = Fluid3D([14264,14410,13707,13334],0); -ELEMENTS[51143] = Fluid3D([16231,16669,16456,15999],0); -ELEMENTS[51144] = Fluid3D([16456,16231,15999,15983],0); -ELEMENTS[51145] = Fluid3D([14185,14195,13484,13027],0); -ELEMENTS[51146] = Fluid3D([16075,16578,16616,16463],0); -ELEMENTS[51147] = Fluid3D([10132,9617,9530,10427],0); -ELEMENTS[51148] = Fluid3D([10132,9617,10427,10536],0); -ELEMENTS[51149] = Fluid3D([13703,14301,13702,13907],0); -ELEMENTS[51150] = Fluid3D([2717,2798,2605,2366],0); -ELEMENTS[51151] = Fluid3D([13046,12879,12035,12099],0); -ELEMENTS[51152] = Fluid3D([12879,12035,12099,12582],0); -ELEMENTS[51153] = Fluid3D([16910,17025,16769,16373],0); -ELEMENTS[51154] = Fluid3D([11770,12090,11006,11160],0); -ELEMENTS[51155] = Fluid3D([2092,2243,2066,1939],0); -ELEMENTS[51156] = Fluid3D([2066,2092,1939,1924],0); -ELEMENTS[51157] = Fluid3D([2092,1939,1924,1809],0); -ELEMENTS[51158] = Fluid3D([3511,3440,3144,3009],0); -ELEMENTS[51159] = Fluid3D([5971,6669,6066,5752],0); -ELEMENTS[51160] = Fluid3D([12236,12936,13091,12851],0); -ELEMENTS[51161] = Fluid3D([12236,12936,12851,11890],0); -ELEMENTS[51162] = Fluid3D([13091,12236,12851,11708],0); -ELEMENTS[51163] = Fluid3D([14314,13695,13908,13867],0); -ELEMENTS[51164] = Fluid3D([14314,13695,13867,14288],0); -ELEMENTS[51165] = Fluid3D([14314,13695,14288,14734],0); -ELEMENTS[51166] = Fluid3D([6822,6254,5790,6571],0); -ELEMENTS[51167] = Fluid3D([11313,10631,10384,11292],0); -ELEMENTS[51168] = Fluid3D([5266,4998,4963,4890],0); -ELEMENTS[51169] = Fluid3D([11300,11536,11211,11888],0); -ELEMENTS[51170] = Fluid3D([14670,14465,15254,14322],0); -ELEMENTS[51171] = Fluid3D([8384,8739,8103,8154],0); -ELEMENTS[51172] = Fluid3D([15013,15431,14948,14718],0); -ELEMENTS[51173] = Fluid3D([15013,15431,14718,14702],0); -ELEMENTS[51174] = Fluid3D([15431,14948,14718,14708],0); -ELEMENTS[51175] = Fluid3D([14718,15431,14708,14702],0); -ELEMENTS[51176] = Fluid3D([14708,14718,14702,14201],0); -ELEMENTS[51177] = Fluid3D([14708,14718,14201,14948],0); -ELEMENTS[51178] = Fluid3D([14718,14702,14201,14636],0); -ELEMENTS[51179] = Fluid3D([14718,14702,14636,15013],0); -ELEMENTS[51180] = Fluid3D([14718,14201,14948,15013],0); -ELEMENTS[51181] = Fluid3D([14636,14718,15013,14201],0); -ELEMENTS[51182] = Fluid3D([10424,9381,10459,9495],0); -ELEMENTS[51183] = Fluid3D([10459,10424,9495,10471],0); -ELEMENTS[51184] = Fluid3D([10459,10424,10471,11236],0); -ELEMENTS[51185] = Fluid3D([1985,2012,1917,1969],0); -ELEMENTS[51186] = Fluid3D([2012,1917,1969,2193],0); -ELEMENTS[51187] = Fluid3D([2012,1917,2193,2126],0); -ELEMENTS[51188] = Fluid3D([16506,16782,16880,16999],0); -ELEMENTS[51189] = Fluid3D([16506,16782,16999,16944],0); -ELEMENTS[51190] = Fluid3D([16782,16880,16999,17349],0); -ELEMENTS[51191] = Fluid3D([9857,9135,9417,8441],0); -ELEMENTS[51192] = Fluid3D([18524,18602,18609,18600],0); -ELEMENTS[51193] = Fluid3D([13817,14550,14022,13607],0); -ELEMENTS[51194] = Fluid3D([14022,13817,13607,13000],0); -ELEMENTS[51195] = Fluid3D([13607,14022,13000,13587],0); -ELEMENTS[51196] = Fluid3D([14550,14022,13607,14396],0); -ELEMENTS[51197] = Fluid3D([14022,13607,14396,14174],0); -ELEMENTS[51198] = Fluid3D([14396,14022,14174,14756],0); -ELEMENTS[51199] = Fluid3D([14396,14022,14756,15255],0); -ELEMENTS[51200] = Fluid3D([14550,14022,14396,15255],0); -ELEMENTS[51201] = Fluid3D([14756,14396,15255,15026],0); -ELEMENTS[51202] = Fluid3D([15255,14756,15026,15328],0); -ELEMENTS[51203] = Fluid3D([14756,15026,15328,14497],0); -ELEMENTS[51204] = Fluid3D([14756,15026,14497,14174],0); -ELEMENTS[51205] = Fluid3D([14756,15026,14174,14396],0); -ELEMENTS[51206] = Fluid3D([14497,14756,14174,14022],0); -ELEMENTS[51207] = Fluid3D([15328,14756,14497,14562],0); -ELEMENTS[51208] = Fluid3D([14756,14497,14562,14022],0); -ELEMENTS[51209] = Fluid3D([14562,14756,14022,15255],0); -ELEMENTS[51210] = Fluid3D([14562,14756,15255,15328],0); -ELEMENTS[51211] = Fluid3D([14497,14562,14022,13587],0); -ELEMENTS[51212] = Fluid3D([12266,11733,11158,10987],0); -ELEMENTS[51213] = Fluid3D([14609,14104,14196,14369],0); -ELEMENTS[51214] = Fluid3D([4066,4074,4250,4609],0); -ELEMENTS[51215] = Fluid3D([16739,17051,16619,16437],0); -ELEMENTS[51216] = Fluid3D([10821,10455,11455,10766],0); -ELEMENTS[51217] = Fluid3D([10455,11455,10766,10973],0); -ELEMENTS[51218] = Fluid3D([10766,10455,10973,10354],0); -ELEMENTS[51219] = Fluid3D([10455,10973,10354,10989],0); -ELEMENTS[51220] = Fluid3D([10455,10973,10989,11455],0); -ELEMENTS[51221] = Fluid3D([11455,10766,10973,11255],0); -ELEMENTS[51222] = Fluid3D([10766,10973,11255,10354],0); -ELEMENTS[51223] = Fluid3D([10973,10354,10989,11685],0); -ELEMENTS[51224] = Fluid3D([10989,10973,11685,11455],0); -ELEMENTS[51225] = Fluid3D([10821,10455,10766,10182],0); -ELEMENTS[51226] = Fluid3D([10455,10766,10182,9017],0); -ELEMENTS[51227] = Fluid3D([10821,10455,10182,9416],0); -ELEMENTS[51228] = Fluid3D([11889,12985,12535,12544],0); -ELEMENTS[51229] = Fluid3D([11681,11108,11336,12538],0); -ELEMENTS[51230] = Fluid3D([13233,12542,13559,12695],0); -ELEMENTS[51231] = Fluid3D([18056,18180,18242,18352],0); -ELEMENTS[51232] = Fluid3D([18056,18180,18352,18312],0); -ELEMENTS[51233] = Fluid3D([4979,4537,4681,4523],0); -ELEMENTS[51234] = Fluid3D([15528,15018,15527,15692],0); -ELEMENTS[51235] = Fluid3D([8750,8103,7973,7897],0); -ELEMENTS[51236] = Fluid3D([14649,14970,14476,14262],0); -ELEMENTS[51237] = Fluid3D([10478,10320,9641,10021],0); -ELEMENTS[51238] = Fluid3D([16082,15538,15455,16016],0); -ELEMENTS[51239] = Fluid3D([3740,3880,3712,4231],0); -ELEMENTS[51240] = Fluid3D([5577,5354,5708,5081],0); -ELEMENTS[51241] = Fluid3D([14852,14312,14378,14874],0); -ELEMENTS[51242] = Fluid3D([4536,4319,4740,4879],0); -ELEMENTS[51243] = Fluid3D([17060,16945,17180,17291],0); -ELEMENTS[51244] = Fluid3D([6662,6781,5887,6736],0); -ELEMENTS[51245] = Fluid3D([6662,6781,6736,7866],0); -ELEMENTS[51246] = Fluid3D([6781,5887,6736,6076],0); -ELEMENTS[51247] = Fluid3D([6781,5887,6076,6711],0); -ELEMENTS[51248] = Fluid3D([6076,6781,6711,6842],0); -ELEMENTS[51249] = Fluid3D([12892,12348,13528,12711],0); -ELEMENTS[51250] = Fluid3D([2234,2167,2261,2034],0); -ELEMENTS[51251] = Fluid3D([7952,8610,8813,7981],0); -ELEMENTS[51252] = Fluid3D([10904,11001,9932,10483],0); -ELEMENTS[51253] = Fluid3D([10904,11001,10483,11618],0); -ELEMENTS[51254] = Fluid3D([5228,5794,5907,5636],0); -ELEMENTS[51255] = Fluid3D([5794,5907,5636,6572],0); -ELEMENTS[51256] = Fluid3D([5228,5794,5636,5139],0); -ELEMENTS[51257] = Fluid3D([5907,5228,5636,5373],0); -ELEMENTS[51258] = Fluid3D([5228,5636,5373,4977],0); -ELEMENTS[51259] = Fluid3D([5636,5907,5373,5843],0); -ELEMENTS[51260] = Fluid3D([5373,5636,5843,4977],0); -ELEMENTS[51261] = Fluid3D([5636,5907,5843,6572],0); -ELEMENTS[51262] = Fluid3D([5843,5636,6572,5945],0); -ELEMENTS[51263] = Fluid3D([5843,5636,5945,5309],0); -ELEMENTS[51264] = Fluid3D([5843,5636,5309,4977],0); -ELEMENTS[51265] = Fluid3D([5636,5309,4977,5228],0); -ELEMENTS[51266] = Fluid3D([5636,5945,5309,5794],0); -ELEMENTS[51267] = Fluid3D([18295,18341,18467,18229],0); -ELEMENTS[51268] = Fluid3D([18295,18341,18229,18075],0); -ELEMENTS[51269] = Fluid3D([18341,18229,18075,18317],0); -ELEMENTS[51270] = Fluid3D([18229,18075,18317,18318],0); -ELEMENTS[51271] = Fluid3D([8346,8180,9030,8757],0); -ELEMENTS[51272] = Fluid3D([9030,8346,8757,8368],0); -ELEMENTS[51273] = Fluid3D([8346,8180,8757,7508],0); -ELEMENTS[51274] = Fluid3D([8757,8346,7508,8368],0); -ELEMENTS[51275] = Fluid3D([3831,3973,4016,3383],0); -ELEMENTS[51276] = Fluid3D([3831,3973,3383,3655],0); -ELEMENTS[51277] = Fluid3D([10612,11135,10638,11820],0); -ELEMENTS[51278] = Fluid3D([3680,3629,4014,3546],0); -ELEMENTS[51279] = Fluid3D([7962,8440,7690,8049],0); -ELEMENTS[51280] = Fluid3D([3919,4185,4165,3603],0); -ELEMENTS[51281] = Fluid3D([17342,17237,17060,16883],0); -ELEMENTS[51282] = Fluid3D([17237,17060,16883,16794],0); -ELEMENTS[51283] = Fluid3D([17237,17060,16794,17258],0); -ELEMENTS[51284] = Fluid3D([5552,5056,5342,5655],0); -ELEMENTS[51285] = Fluid3D([5552,5056,5655,5363],0); -ELEMENTS[51286] = Fluid3D([5655,5552,5363,6042],0); -ELEMENTS[51287] = Fluid3D([5552,5056,5363,4784],0); -ELEMENTS[51288] = Fluid3D([5342,5552,5655,6109],0); -ELEMENTS[51289] = Fluid3D([5552,5655,6109,6042],0); -ELEMENTS[51290] = Fluid3D([18391,18248,18451,18333],0); -ELEMENTS[51291] = Fluid3D([18248,18451,18333,18332],0); -ELEMENTS[51292] = Fluid3D([18333,18248,18332,18132],0); -ELEMENTS[51293] = Fluid3D([18248,18332,18132,18241],0); -ELEMENTS[51294] = Fluid3D([18248,18451,18332,18241],0); -ELEMENTS[51295] = Fluid3D([16258,16126,16469,15676],0); -ELEMENTS[51296] = Fluid3D([6431,5957,5629,6245],0); -ELEMENTS[51297] = Fluid3D([18494,18458,18576,18438],0); -ELEMENTS[51298] = Fluid3D([18494,18458,18438,18222],0); -ELEMENTS[51299] = Fluid3D([14067,14741,13669,13901],0); -ELEMENTS[51300] = Fluid3D([14067,14741,13901,13998],0); -ELEMENTS[51301] = Fluid3D([13669,14067,13901,13465],0); -ELEMENTS[51302] = Fluid3D([14067,13901,13465,13998],0); -ELEMENTS[51303] = Fluid3D([13901,13669,13465,13146],0); -ELEMENTS[51304] = Fluid3D([13669,14067,13465,13248],0); -ELEMENTS[51305] = Fluid3D([13465,14067,13998,13248],0); -ELEMENTS[51306] = Fluid3D([13465,13901,13146,13517],0); -ELEMENTS[51307] = Fluid3D([13465,13901,13517,13998],0); -ELEMENTS[51308] = Fluid3D([13517,13465,13998,12702],0); -ELEMENTS[51309] = Fluid3D([13998,13465,13248,12702],0); -ELEMENTS[51310] = Fluid3D([13465,13248,12702,12690],0); -ELEMENTS[51311] = Fluid3D([13248,12702,12690,12706],0); -ELEMENTS[51312] = Fluid3D([13517,13465,12702,13146],0); -ELEMENTS[51313] = Fluid3D([12690,13248,12706,13256],0); -ELEMENTS[51314] = Fluid3D([17802,17447,17530,17842],0); -ELEMENTS[51315] = Fluid3D([12404,12206,12575,13618],0); -ELEMENTS[51316] = Fluid3D([6745,6493,5909,6457],0); -ELEMENTS[51317] = Fluid3D([6745,6493,6457,7040],0); -ELEMENTS[51318] = Fluid3D([14014,14580,13913,14608],0); -ELEMENTS[51319] = Fluid3D([13913,14014,14608,14300],0); -ELEMENTS[51320] = Fluid3D([14014,14608,14300,15046],0); -ELEMENTS[51321] = Fluid3D([14580,13913,14608,14519],0); -ELEMENTS[51322] = Fluid3D([12623,12822,12056,12569],0); -ELEMENTS[51323] = Fluid3D([11555,11050,11136,11205],0); -ELEMENTS[51324] = Fluid3D([14749,15381,15346,15022],0); -ELEMENTS[51325] = Fluid3D([7433,8114,7721,8366],0); -ELEMENTS[51326] = Fluid3D([3756,3520,3935,4057],0); -ELEMENTS[51327] = Fluid3D([14771,15235,14990,14898],0); -ELEMENTS[51328] = Fluid3D([14771,15235,14898,15040],0); -ELEMENTS[51329] = Fluid3D([14990,14771,14898,14318],0); -ELEMENTS[51330] = Fluid3D([14771,14898,14318,14129],0); -ELEMENTS[51331] = Fluid3D([14318,14771,14129,13962],0); -ELEMENTS[51332] = Fluid3D([14990,14771,14318,14683],0); -ELEMENTS[51333] = Fluid3D([14898,14318,14129,14663],0); -ELEMENTS[51334] = Fluid3D([14898,14318,14663,14990],0); -ELEMENTS[51335] = Fluid3D([15235,14898,15040,15620],0); -ELEMENTS[51336] = Fluid3D([15040,15235,15620,15397],0); -ELEMENTS[51337] = Fluid3D([15235,14898,15620,14990],0); -ELEMENTS[51338] = Fluid3D([14318,14771,13962,14683],0); -ELEMENTS[51339] = Fluid3D([14771,14898,14129,15040],0); -ELEMENTS[51340] = Fluid3D([17323,17497,17756,17514],0); -ELEMENTS[51341] = Fluid3D([8102,8174,8745,7326],0); -ELEMENTS[51342] = Fluid3D([12129,11918,12027,11397],0); -ELEMENTS[51343] = Fluid3D([12027,12129,11397,12149],0); -ELEMENTS[51344] = Fluid3D([11397,12027,12149,11347],0); -ELEMENTS[51345] = Fluid3D([12027,12149,11347,12409],0); -ELEMENTS[51346] = Fluid3D([3007,2686,2675,2944],0); -ELEMENTS[51347] = Fluid3D([3007,2686,2944,2855],0); -ELEMENTS[51348] = Fluid3D([2817,2626,2485,2724],0); -ELEMENTS[51349] = Fluid3D([2626,2485,2724,2749],0); -ELEMENTS[51350] = Fluid3D([2485,2817,2724,2805],0); -ELEMENTS[51351] = Fluid3D([2485,2724,2749,2389],0); -ELEMENTS[51352] = Fluid3D([2485,2724,2389,2652],0); -ELEMENTS[51353] = Fluid3D([5755,5295,5251,5761],0); -ELEMENTS[51354] = Fluid3D([5251,5755,5761,5822],0); -ELEMENTS[51355] = Fluid3D([5755,5295,5761,6253],0); -ELEMENTS[51356] = Fluid3D([5761,5755,6253,6352],0); -ELEMENTS[51357] = Fluid3D([5761,5755,6352,5822],0); -ELEMENTS[51358] = Fluid3D([13625,14482,14070,13743],0); -ELEMENTS[51359] = Fluid3D([13342,13722,13533,14386],0); -ELEMENTS[51360] = Fluid3D([15877,15985,15523,15716],0); -ELEMENTS[51361] = Fluid3D([16467,16455,15830,16071],0); -ELEMENTS[51362] = Fluid3D([16467,16455,16071,16799],0); -ELEMENTS[51363] = Fluid3D([14097,13716,13001,14105],0); -ELEMENTS[51364] = Fluid3D([6646,6396,6450,7395],0); -ELEMENTS[51365] = Fluid3D([3069,3138,3447,3155],0); -ELEMENTS[51366] = Fluid3D([5403,5188,5576,5205],0); -ELEMENTS[51367] = Fluid3D([10233,9602,9984,10882],0); -ELEMENTS[51368] = Fluid3D([7689,7150,6996,6752],0); -ELEMENTS[51369] = Fluid3D([8895,9274,9488,10474],0); -ELEMENTS[51370] = Fluid3D([11551,10820,10531,11020],0); -ELEMENTS[51371] = Fluid3D([10531,11551,11020,11159],0); -ELEMENTS[51372] = Fluid3D([11655,11205,11078,12072],0); -ELEMENTS[51373] = Fluid3D([3082,3336,3577,3522],0); -ELEMENTS[51374] = Fluid3D([14195,14850,14523,14749],0); -ELEMENTS[51375] = Fluid3D([14850,14523,14749,15054],0); -ELEMENTS[51376] = Fluid3D([17710,17833,17940,17595],0); -ELEMENTS[51377] = Fluid3D([12392,12382,13177,12358],0); -ELEMENTS[51378] = Fluid3D([13177,12392,12358,12922],0); -ELEMENTS[51379] = Fluid3D([13177,12392,12922,12737],0); -ELEMENTS[51380] = Fluid3D([12392,12922,12737,12130],0); -ELEMENTS[51381] = Fluid3D([12392,12922,12130,11481],0); -ELEMENTS[51382] = Fluid3D([12737,12392,12130,11737],0); -ELEMENTS[51383] = Fluid3D([12130,12392,11481,11737],0); -ELEMENTS[51384] = Fluid3D([11481,12130,11737,10977],0); -ELEMENTS[51385] = Fluid3D([12130,12737,11737,12301],0); -ELEMENTS[51386] = Fluid3D([11737,12130,12301,10977],0); -ELEMENTS[51387] = Fluid3D([11481,12130,10977,12220],0); -ELEMENTS[51388] = Fluid3D([11481,12130,12220,12922],0); -ELEMENTS[51389] = Fluid3D([12130,12220,12922,12301],0); -ELEMENTS[51390] = Fluid3D([12130,12220,12301,10977],0); -ELEMENTS[51391] = Fluid3D([12922,12737,12130,12301],0); -ELEMENTS[51392] = Fluid3D([12454,11889,12583,12855],0); -ELEMENTS[51393] = Fluid3D([11109,11306,11257,11972],0); -ELEMENTS[51394] = Fluid3D([11109,11306,11972,12065],0); -ELEMENTS[51395] = Fluid3D([13405,13821,14239,14412],0); -ELEMENTS[51396] = Fluid3D([11837,11517,11467,12315],0); -ELEMENTS[51397] = Fluid3D([11837,11517,12315,12160],0); -ELEMENTS[51398] = Fluid3D([17381,17738,17753,17467],0); -ELEMENTS[51399] = Fluid3D([13879,14169,13633,14491],0); -ELEMENTS[51400] = Fluid3D([13633,13879,14491,14147],0); -ELEMENTS[51401] = Fluid3D([13529,13651,14232,14431],0); -ELEMENTS[51402] = Fluid3D([13651,14232,14431,13935],0); -ELEMENTS[51403] = Fluid3D([13651,14232,13935,13727],0); -ELEMENTS[51404] = Fluid3D([13935,13651,13727,13425],0); -ELEMENTS[51405] = Fluid3D([13651,14232,13727,13275],0); -ELEMENTS[51406] = Fluid3D([14431,13651,13935,13492],0); -ELEMENTS[51407] = Fluid3D([13651,13935,13492,12601],0); -ELEMENTS[51408] = Fluid3D([13935,13651,13425,12601],0); -ELEMENTS[51409] = Fluid3D([17513,17147,17198,17496],0); -ELEMENTS[51410] = Fluid3D([10217,10268,11119,11012],0); -ELEMENTS[51411] = Fluid3D([17515,17469,17470,17014],0); -ELEMENTS[51412] = Fluid3D([17799,17708,17589,17335],0); -ELEMENTS[51413] = Fluid3D([8530,8771,8359,7581],0); -ELEMENTS[51414] = Fluid3D([7898,8162,8683,8685],0); -ELEMENTS[51415] = Fluid3D([8162,8683,8685,9476],0); -ELEMENTS[51416] = Fluid3D([7387,7553,7252,7978],0); -ELEMENTS[51417] = Fluid3D([7252,7387,7978,8340],0); -ELEMENTS[51418] = Fluid3D([12580,13353,13125,12878],0); -ELEMENTS[51419] = Fluid3D([16001,16468,16778,16500],0); -ELEMENTS[51420] = Fluid3D([5411,5532,6031,5718],0); -ELEMENTS[51421] = Fluid3D([5411,5532,5718,4827],0); -ELEMENTS[51422] = Fluid3D([6031,5411,5718,5887],0); -ELEMENTS[51423] = Fluid3D([5532,6031,5718,6600],0); -ELEMENTS[51424] = Fluid3D([6031,5718,6600,6166],0); -ELEMENTS[51425] = Fluid3D([18423,18514,18515,18581],0); -ELEMENTS[51426] = Fluid3D([12009,11977,12176,11186],0); -ELEMENTS[51427] = Fluid3D([6944,7860,7258,7154],0); -ELEMENTS[51428] = Fluid3D([7940,7501,8344,8350],0); -ELEMENTS[51429] = Fluid3D([8344,7940,8350,8884],0); -ELEMENTS[51430] = Fluid3D([13870,13431,14322,13855],0); -ELEMENTS[51431] = Fluid3D([17503,17372,17384,17785],0); -ELEMENTS[51432] = Fluid3D([5681,5388,6065,5935],0); -ELEMENTS[51433] = Fluid3D([4414,4863,5088,4742],0); -ELEMENTS[51434] = Fluid3D([5088,4414,4742,4765],0); -ELEMENTS[51435] = Fluid3D([4742,5088,4765,5612],0); -ELEMENTS[51436] = Fluid3D([6001,6763,6149,6212],0); -ELEMENTS[51437] = Fluid3D([9149,10057,8908,9132],0); -ELEMENTS[51438] = Fluid3D([2768,2566,3032,2653],0); -ELEMENTS[51439] = Fluid3D([4608,4255,4288,4558],0); -ELEMENTS[51440] = Fluid3D([15563,15281,15928,16135],0); -ELEMENTS[51441] = Fluid3D([11306,11034,10235,11257],0); -ELEMENTS[51442] = Fluid3D([4070,3783,3646,3692],0); -ELEMENTS[51443] = Fluid3D([14831,14863,15492,15134],0); -ELEMENTS[51444] = Fluid3D([17644,17687,17772,18046],0); -ELEMENTS[51445] = Fluid3D([13307,13932,13774,13926],0); -ELEMENTS[51446] = Fluid3D([1786,1916,1833,1713],0); -ELEMENTS[51447] = Fluid3D([12686,13553,13596,13175],0); -ELEMENTS[51448] = Fluid3D([7662,8334,7778,7107],0); -ELEMENTS[51449] = Fluid3D([13716,14097,14688,14105],0); -ELEMENTS[51450] = Fluid3D([8298,8541,8085,8551],0); -ELEMENTS[51451] = Fluid3D([2957,3330,3149,3107],0); -ELEMENTS[51452] = Fluid3D([9887,10178,10569,9649],0); -ELEMENTS[51453] = Fluid3D([3238,3267,3094,2886],0); -ELEMENTS[51454] = Fluid3D([3238,3267,2886,3040],0); -ELEMENTS[51455] = Fluid3D([8512,8207,7610,8052],0); -ELEMENTS[51456] = Fluid3D([8742,8117,7722,7280],0); -ELEMENTS[51457] = Fluid3D([2852,3007,3096,3103],0); -ELEMENTS[51458] = Fluid3D([2852,3007,3103,3154],0); -ELEMENTS[51459] = Fluid3D([3103,2852,3154,3012],0); -ELEMENTS[51460] = Fluid3D([3103,2852,3012,2853],0); -ELEMENTS[51461] = Fluid3D([2852,3007,3154,2855],0); -ELEMENTS[51462] = Fluid3D([15781,15242,15288,15440],0); -ELEMENTS[51463] = Fluid3D([8437,8307,8752,7603],0); -ELEMENTS[51464] = Fluid3D([12525,11900,12287,12702],0); -ELEMENTS[51465] = Fluid3D([17079,16849,16808,16792],0); -ELEMENTS[51466] = Fluid3D([10200,10764,10369,10005],0); -ELEMENTS[51467] = Fluid3D([6811,6149,6763,6212],0); -ELEMENTS[51468] = Fluid3D([10652,10882,10029,9602],0); -ELEMENTS[51469] = Fluid3D([5450,5650,4948,5498],0); -ELEMENTS[51470] = Fluid3D([5348,5493,4691,5059],0); -ELEMENTS[51471] = Fluid3D([5348,5493,5059,5273],0); -ELEMENTS[51472] = Fluid3D([8076,9057,8056,8341],0); -ELEMENTS[51473] = Fluid3D([4040,4304,3822,4047],0); -ELEMENTS[51474] = Fluid3D([9020,9701,9770,9259],0); -ELEMENTS[51475] = Fluid3D([2354,2099,2194,2074],0); -ELEMENTS[51476] = Fluid3D([2099,2194,2074,1942],0); -ELEMENTS[51477] = Fluid3D([2194,2354,2074,2338],0); -ELEMENTS[51478] = Fluid3D([2074,2194,2338,2056],0); -ELEMENTS[51479] = Fluid3D([2194,2338,2056,2292],0); -ELEMENTS[51480] = Fluid3D([2074,2194,2056,1942],0); -ELEMENTS[51481] = Fluid3D([2194,2056,1942,2163],0); -ELEMENTS[51482] = Fluid3D([2194,2056,2163,2292],0); -ELEMENTS[51483] = Fluid3D([2056,2074,1942,1928],0); -ELEMENTS[51484] = Fluid3D([9088,8351,8745,9261],0); -ELEMENTS[51485] = Fluid3D([6495,7164,7181,6271],0); -ELEMENTS[51486] = Fluid3D([3137,3173,3156,2859],0); -ELEMENTS[51487] = Fluid3D([13894,14223,13453,14601],0); -ELEMENTS[51488] = Fluid3D([5963,5572,5715,5053],0); -ELEMENTS[51489] = Fluid3D([15419,15691,15234,15867],0); -ELEMENTS[51490] = Fluid3D([14030,13060,13822,13927],0); -ELEMENTS[51491] = Fluid3D([15421,14802,14908,15545],0); -ELEMENTS[51492] = Fluid3D([6345,6023,5546,6244],0); -ELEMENTS[51493] = Fluid3D([6345,6023,6244,6646],0); -ELEMENTS[51494] = Fluid3D([6244,6345,6646,6651],0); -ELEMENTS[51495] = Fluid3D([6244,6345,6651,5896],0); -ELEMENTS[51496] = Fluid3D([6244,6345,5896,5546],0); -ELEMENTS[51497] = Fluid3D([6345,6651,5896,5964],0); -ELEMENTS[51498] = Fluid3D([6345,6646,6651,7168],0); -ELEMENTS[51499] = Fluid3D([5896,6345,5964,5913],0); -ELEMENTS[51500] = Fluid3D([5964,5896,5913,5288],0); -ELEMENTS[51501] = Fluid3D([5896,6345,5913,5546],0); -ELEMENTS[51502] = Fluid3D([5913,5896,5546,5288],0); -ELEMENTS[51503] = Fluid3D([6646,6244,6651,6996],0); -ELEMENTS[51504] = Fluid3D([3808,3382,3369,3783],0); -ELEMENTS[51505] = Fluid3D([3808,3382,3783,3381],0); -ELEMENTS[51506] = Fluid3D([14395,13654,14008,14627],0); -ELEMENTS[51507] = Fluid3D([14270,14279,14183,14964],0); -ELEMENTS[51508] = Fluid3D([14279,14183,14964,14473],0); -ELEMENTS[51509] = Fluid3D([16682,16403,17015,16841],0); -ELEMENTS[51510] = Fluid3D([16682,16403,16841,16478],0); -ELEMENTS[51511] = Fluid3D([8332,8608,7889,7652],0); -ELEMENTS[51512] = Fluid3D([12064,11237,12193,11577],0); -ELEMENTS[51513] = Fluid3D([12064,11237,11577,11199],0); -ELEMENTS[51514] = Fluid3D([12193,12064,11577,12319],0); -ELEMENTS[51515] = Fluid3D([11577,12193,12319,11041],0); -ELEMENTS[51516] = Fluid3D([11577,12064,11199,12319],0); -ELEMENTS[51517] = Fluid3D([11199,11577,12319,11200],0); -ELEMENTS[51518] = Fluid3D([11199,11577,11200,11237],0); -ELEMENTS[51519] = Fluid3D([11577,12319,11200,11041],0); -ELEMENTS[51520] = Fluid3D([11200,11577,11041,11237],0); -ELEMENTS[51521] = Fluid3D([12319,11199,11200,11602],0); -ELEMENTS[51522] = Fluid3D([11199,11200,11602,10441],0); -ELEMENTS[51523] = Fluid3D([11199,11200,10441,11237],0); -ELEMENTS[51524] = Fluid3D([11237,12193,11577,11041],0); -ELEMENTS[51525] = Fluid3D([12911,13106,13620,13466],0); -ELEMENTS[51526] = Fluid3D([13620,12911,13466,13956],0); -ELEMENTS[51527] = Fluid3D([10120,9908,9816,9089],0); -ELEMENTS[51528] = Fluid3D([11363,11162,10248,11332],0); -ELEMENTS[51529] = Fluid3D([10248,11363,11332,10516],0); -ELEMENTS[51530] = Fluid3D([11363,11162,11332,12209],0); -ELEMENTS[51531] = Fluid3D([16534,16113,16688,16881],0); -ELEMENTS[51532] = Fluid3D([4717,5231,4738,4799],0); -ELEMENTS[51533] = Fluid3D([10591,11287,10061,10078],0); -ELEMENTS[51534] = Fluid3D([10061,10591,10078,9614],0); -ELEMENTS[51535] = Fluid3D([10591,11287,10078,10541],0); -ELEMENTS[51536] = Fluid3D([10078,10591,10541,10351],0); -ELEMENTS[51537] = Fluid3D([10541,10078,10351,9352],0); -ELEMENTS[51538] = Fluid3D([10541,10078,9352,10061],0); -ELEMENTS[51539] = Fluid3D([10541,10078,10061,11287],0); -ELEMENTS[51540] = Fluid3D([10078,9352,10061,9157],0); -ELEMENTS[51541] = Fluid3D([10061,10078,9157,9614],0); -ELEMENTS[51542] = Fluid3D([14167,13650,13492,13935],0); -ELEMENTS[51543] = Fluid3D([13492,14167,13935,14431],0); -ELEMENTS[51544] = Fluid3D([13650,13492,13935,12601],0); -ELEMENTS[51545] = Fluid3D([9776,9368,8608,8711],0); -ELEMENTS[51546] = Fluid3D([3501,3819,3245,3639],0); -ELEMENTS[51547] = Fluid3D([6738,6917,6460,5974],0); -ELEMENTS[51548] = Fluid3D([6917,6460,5974,6838],0); -ELEMENTS[51549] = Fluid3D([17856,17967,18048,17738],0); -ELEMENTS[51550] = Fluid3D([17856,17967,17738,17749],0); -ELEMENTS[51551] = Fluid3D([17967,17738,17749,18020],0); -ELEMENTS[51552] = Fluid3D([17967,17738,18020,18048],0); -ELEMENTS[51553] = Fluid3D([3525,3973,3655,3383],0); -ELEMENTS[51554] = Fluid3D([6185,6520,7025,6184],0); -ELEMENTS[51555] = Fluid3D([6196,5626,6116,5757],0); -ELEMENTS[51556] = Fluid3D([6756,6518,6165,6058],0); -ELEMENTS[51557] = Fluid3D([11084,11374,11892,11575],0); -ELEMENTS[51558] = Fluid3D([16132,15479,16014,15798],0); -ELEMENTS[51559] = Fluid3D([16014,16132,15798,16586],0); -ELEMENTS[51560] = Fluid3D([15140,15565,15816,15297],0); -ELEMENTS[51561] = Fluid3D([8542,9053,8245,9086],0); -ELEMENTS[51562] = Fluid3D([17373,17435,17148,17456],0); -ELEMENTS[51563] = Fluid3D([8079,7337,8309,7432],0); -ELEMENTS[51564] = Fluid3D([8079,7337,7432,7639],0); -ELEMENTS[51565] = Fluid3D([7337,8309,7432,7613],0); -ELEMENTS[51566] = Fluid3D([7337,7432,7639,6993],0); -ELEMENTS[51567] = Fluid3D([10056,9164,9735,9936],0); -ELEMENTS[51568] = Fluid3D([12814,12269,12064,13217],0); -ELEMENTS[51569] = Fluid3D([13610,14063,14445,13718],0); -ELEMENTS[51570] = Fluid3D([13451,12608,12572,13185],0); -ELEMENTS[51571] = Fluid3D([6020,5513,5685,6005],0); -ELEMENTS[51572] = Fluid3D([17891,18034,18116,18006],0); -ELEMENTS[51573] = Fluid3D([18116,17891,18006,17898],0); -ELEMENTS[51574] = Fluid3D([18116,17891,17898,18028],0); -ELEMENTS[51575] = Fluid3D([17891,18006,17898,17545],0); -ELEMENTS[51576] = Fluid3D([10467,9797,9919,11077],0); -ELEMENTS[51577] = Fluid3D([3611,3545,3296,3441],0); -ELEMENTS[51578] = Fluid3D([3545,3296,3441,3851],0); -ELEMENTS[51579] = Fluid3D([3441,3545,3851,3611],0); -ELEMENTS[51580] = Fluid3D([3545,3296,3851,3607],0); -ELEMENTS[51581] = Fluid3D([3545,3296,3607,3109],0); -ELEMENTS[51582] = Fluid3D([3545,3296,3109,3269],0); -ELEMENTS[51583] = Fluid3D([3851,3545,3607,3843],0); -ELEMENTS[51584] = Fluid3D([4689,4354,4041,4522],0); -ELEMENTS[51585] = Fluid3D([4689,4354,4522,4874],0); -ELEMENTS[51586] = Fluid3D([4522,4689,4874,5078],0); -ELEMENTS[51587] = Fluid3D([4689,4354,4874,4680],0); -ELEMENTS[51588] = Fluid3D([4041,4689,4522,4726],0); -ELEMENTS[51589] = Fluid3D([4689,4522,4726,5103],0); -ELEMENTS[51590] = Fluid3D([4689,4522,5103,5078],0); -ELEMENTS[51591] = Fluid3D([4726,4689,5103,5299],0); -ELEMENTS[51592] = Fluid3D([4689,5103,5299,5364],0); -ELEMENTS[51593] = Fluid3D([5103,4726,5299,5174],0); -ELEMENTS[51594] = Fluid3D([4522,5103,5078,4725],0); -ELEMENTS[51595] = Fluid3D([5159,4948,4876,4604],0); -ELEMENTS[51596] = Fluid3D([10577,11344,10794,11273],0); -ELEMENTS[51597] = Fluid3D([2544,2767,2709,2445],0); -ELEMENTS[51598] = Fluid3D([2544,2767,2445,2500],0); -ELEMENTS[51599] = Fluid3D([2445,2544,2500,2213],0); -ELEMENTS[51600] = Fluid3D([2544,2767,2500,2588],0); -ELEMENTS[51601] = Fluid3D([2709,2544,2445,2421],0); -ELEMENTS[51602] = Fluid3D([2544,2445,2421,2270],0); -ELEMENTS[51603] = Fluid3D([2445,2544,2213,2270],0); -ELEMENTS[51604] = Fluid3D([2445,2709,2421,2396],0); -ELEMENTS[51605] = Fluid3D([2421,2445,2396,2173],0); -ELEMENTS[51606] = Fluid3D([2709,2421,2396,2439],0); -ELEMENTS[51607] = Fluid3D([2421,2396,2439,2173],0); -ELEMENTS[51608] = Fluid3D([17412,17156,17577,17502],0); -ELEMENTS[51609] = Fluid3D([6923,6810,7316,7728],0); -ELEMENTS[51610] = Fluid3D([6872,7429,7519,7428],0); -ELEMENTS[51611] = Fluid3D([6872,7429,7428,8179],0); -ELEMENTS[51612] = Fluid3D([11478,11549,11395,12354],0); -ELEMENTS[51613] = Fluid3D([11609,12761,11367,12348],0); -ELEMENTS[51614] = Fluid3D([15352,15875,15987,15860],0); -ELEMENTS[51615] = Fluid3D([9961,9688,9109,9850],0); -ELEMENTS[51616] = Fluid3D([16277,16296,16387,15555],0); -ELEMENTS[51617] = Fluid3D([17261,16933,16861,16888],0); -ELEMENTS[51618] = Fluid3D([11762,10886,10916,10621],0); -ELEMENTS[51619] = Fluid3D([10886,10916,10621,9618],0); -ELEMENTS[51620] = Fluid3D([7027,6313,6119,6694],0); -ELEMENTS[51621] = Fluid3D([6313,6119,6694,5894],0); -ELEMENTS[51622] = Fluid3D([6313,6119,5894,5807],0); -ELEMENTS[51623] = Fluid3D([11796,10926,11458,12310],0); -ELEMENTS[51624] = Fluid3D([11458,11796,12310,11966],0); -ELEMENTS[51625] = Fluid3D([10468,10192,9686,9181],0); -ELEMENTS[51626] = Fluid3D([9968,10910,10403,11256],0); -ELEMENTS[51627] = Fluid3D([4111,3797,3854,3547],0); -ELEMENTS[51628] = Fluid3D([13103,12417,13272,13652],0); -ELEMENTS[51629] = Fluid3D([9996,10836,9900,10732],0); -ELEMENTS[51630] = Fluid3D([5778,6278,6008,5995],0); -ELEMENTS[51631] = Fluid3D([5778,6278,5995,5847],0); -ELEMENTS[51632] = Fluid3D([15993,15761,15809,16290],0); -ELEMENTS[51633] = Fluid3D([8549,8880,8770,7818],0); -ELEMENTS[51634] = Fluid3D([10018,9777,10484,9540],0); -ELEMENTS[51635] = Fluid3D([10018,9777,9540,8861],0); -ELEMENTS[51636] = Fluid3D([14186,14831,14559,15134],0); -ELEMENTS[51637] = Fluid3D([3776,3927,4215,3811],0); -ELEMENTS[51638] = Fluid3D([4215,3776,3811,3713],0); -ELEMENTS[51639] = Fluid3D([3776,3811,3713,3312],0); -ELEMENTS[51640] = Fluid3D([3776,3927,3811,3526],0); -ELEMENTS[51641] = Fluid3D([3927,3811,3526,4120],0); -ELEMENTS[51642] = Fluid3D([3811,3776,3526,3312],0); -ELEMENTS[51643] = Fluid3D([3526,3811,3312,3572],0); -ELEMENTS[51644] = Fluid3D([3526,3811,3572,4120],0); -ELEMENTS[51645] = Fluid3D([3811,3312,3572,3713],0); -ELEMENTS[51646] = Fluid3D([3572,3811,3713,3993],0); -ELEMENTS[51647] = Fluid3D([3572,3811,3993,4120],0); -ELEMENTS[51648] = Fluid3D([3927,4215,3811,4120],0); -ELEMENTS[51649] = Fluid3D([6218,6526,6951,6341],0); -ELEMENTS[51650] = Fluid3D([6801,7484,6612,6232],0); -ELEMENTS[51651] = Fluid3D([17319,17419,17164,16980],0); -ELEMENTS[51652] = Fluid3D([13481,12557,13090,13531],0); -ELEMENTS[51653] = Fluid3D([17624,18011,17876,17948],0); -ELEMENTS[51654] = Fluid3D([14395,14521,14039,13900],0); -ELEMENTS[51655] = Fluid3D([14521,14039,13900,14883],0); -ELEMENTS[51656] = Fluid3D([5755,5822,6349,6352],0); -ELEMENTS[51657] = Fluid3D([10982,11244,10273,10400],0); -ELEMENTS[51658] = Fluid3D([11924,12612,12087,12751],0); -ELEMENTS[51659] = Fluid3D([6112,5803,5742,6495],0); -ELEMENTS[51660] = Fluid3D([10606,9774,10070,9902],0); -ELEMENTS[51661] = Fluid3D([17515,17721,17136,17619],0); -ELEMENTS[51662] = Fluid3D([7889,7849,7410,7652],0); -ELEMENTS[51663] = Fluid3D([17737,17920,18108,17692],0); -ELEMENTS[51664] = Fluid3D([12738,12099,13145,13046],0); -ELEMENTS[51665] = Fluid3D([2640,2689,2729,2890],0); -ELEMENTS[51666] = Fluid3D([2640,2689,2890,3071],0); -ELEMENTS[51667] = Fluid3D([2689,2729,2890,2981],0); -ELEMENTS[51668] = Fluid3D([10501,11174,11429,10466],0); -ELEMENTS[51669] = Fluid3D([12159,13092,12302,12212],0); -ELEMENTS[51670] = Fluid3D([8358,7458,8282,7904],0); -ELEMENTS[51671] = Fluid3D([2800,2482,2647,2739],0); -ELEMENTS[51672] = Fluid3D([6021,5493,5893,5978],0); -ELEMENTS[51673] = Fluid3D([8699,9434,8575,8151],0); -ELEMENTS[51674] = Fluid3D([14130,13617,13399,14362],0); -ELEMENTS[51675] = Fluid3D([7141,6281,7221,6725],0); -ELEMENTS[51676] = Fluid3D([3826,4090,3676,3560],0); -ELEMENTS[51677] = Fluid3D([4579,4478,4251,4033],0); -ELEMENTS[51678] = Fluid3D([4251,4579,4033,4307],0); -ELEMENTS[51679] = Fluid3D([4579,4478,4033,4426],0); -ELEMENTS[51680] = Fluid3D([4579,4478,4426,4920],0); -ELEMENTS[51681] = Fluid3D([4033,4579,4426,3983],0); -ELEMENTS[51682] = Fluid3D([4426,4579,4920,5050],0); -ELEMENTS[51683] = Fluid3D([4426,4579,5050,4699],0); -ELEMENTS[51684] = Fluid3D([4579,5050,4699,4746],0); -ELEMENTS[51685] = Fluid3D([4426,4579,4699,3983],0); -ELEMENTS[51686] = Fluid3D([8550,8353,9174,9688],0); -ELEMENTS[51687] = Fluid3D([8478,8951,8089,7652],0); -ELEMENTS[51688] = Fluid3D([8089,8478,7652,7849],0); -ELEMENTS[51689] = Fluid3D([15832,15430,15383,15529],0); -ELEMENTS[51690] = Fluid3D([15383,15832,15529,15937],0); -ELEMENTS[51691] = Fluid3D([15529,15383,15937,15392],0); -ELEMENTS[51692] = Fluid3D([15383,15832,15937,15860],0); -ELEMENTS[51693] = Fluid3D([15430,15383,15529,14627],0); -ELEMENTS[51694] = Fluid3D([15120,14942,15143,15778],0); -ELEMENTS[51695] = Fluid3D([17722,17782,17787,18038],0); -ELEMENTS[51696] = Fluid3D([16157,15999,15786,16580],0); -ELEMENTS[51697] = Fluid3D([9140,8840,9377,9590],0); -ELEMENTS[51698] = Fluid3D([16551,16306,16926,16496],0); -ELEMENTS[51699] = Fluid3D([16551,16306,16496,16213],0); -ELEMENTS[51700] = Fluid3D([16926,16551,16496,17083],0); -ELEMENTS[51701] = Fluid3D([16496,16551,16213,16582],0); -ELEMENTS[51702] = Fluid3D([16496,16551,16582,17083],0); -ELEMENTS[51703] = Fluid3D([16306,16926,16496,16475],0); -ELEMENTS[51704] = Fluid3D([16496,16306,16475,15749],0); -ELEMENTS[51705] = Fluid3D([16926,16496,16475,16805],0); -ELEMENTS[51706] = Fluid3D([16306,16926,16475,16683],0); -ELEMENTS[51707] = Fluid3D([16496,16475,16805,16355],0); -ELEMENTS[51708] = Fluid3D([16496,16475,16355,15749],0); -ELEMENTS[51709] = Fluid3D([16496,16306,15749,16213],0); -ELEMENTS[51710] = Fluid3D([2914,2751,2957,2898],0); -ELEMENTS[51711] = Fluid3D([13116,12373,13341,13715],0); -ELEMENTS[51712] = Fluid3D([13341,13116,13715,14323],0); -ELEMENTS[51713] = Fluid3D([14980,15497,15493,15307],0); -ELEMENTS[51714] = Fluid3D([8590,8634,9381,8790],0); -ELEMENTS[51715] = Fluid3D([8117,8742,7747,7280],0); -ELEMENTS[51716] = Fluid3D([16936,16857,16432,16756],0); -ELEMENTS[51717] = Fluid3D([16936,16857,16756,17296],0); -ELEMENTS[51718] = Fluid3D([10017,11109,10538,10235],0); -ELEMENTS[51719] = Fluid3D([12493,12642,11896,11676],0); -ELEMENTS[51720] = Fluid3D([16662,16521,16244,16742],0); -ELEMENTS[51721] = Fluid3D([16662,16521,16742,17110],0); -ELEMENTS[51722] = Fluid3D([18342,18156,18093,18257],0); -ELEMENTS[51723] = Fluid3D([18342,18156,18257,18356],0); -ELEMENTS[51724] = Fluid3D([18156,18093,18257,18090],0); -ELEMENTS[51725] = Fluid3D([18257,18156,18090,18356],0); -ELEMENTS[51726] = Fluid3D([18090,18257,18356,18198],0); -ELEMENTS[51727] = Fluid3D([2494,2398,2566,2300],0); -ELEMENTS[51728] = Fluid3D([2398,2566,2300,2464],0); -ELEMENTS[51729] = Fluid3D([12576,12080,11582,12734],0); -ELEMENTS[51730] = Fluid3D([9577,9960,10541,10454],0); -ELEMENTS[51731] = Fluid3D([18679,18691,18688,18696],0); -ELEMENTS[51732] = Fluid3D([9266,9856,10403,10112],0); -ELEMENTS[51733] = Fluid3D([2569,2801,2750,2436],0); -ELEMENTS[51734] = Fluid3D([3117,2984,2714,2733],0); -ELEMENTS[51735] = Fluid3D([3117,2984,2733,2976],0); -ELEMENTS[51736] = Fluid3D([6018,6364,7031,6904],0); -ELEMENTS[51737] = Fluid3D([12063,12023,12627,11663],0); -ELEMENTS[51738] = Fluid3D([4131,4100,4138,4632],0); -ELEMENTS[51739] = Fluid3D([4100,4138,4632,4172],0); -ELEMENTS[51740] = Fluid3D([15062,14670,15254,15326],0); -ELEMENTS[51741] = Fluid3D([14670,15254,15326,15055],0); -ELEMENTS[51742] = Fluid3D([2836,2866,2616,2558],0); -ELEMENTS[51743] = Fluid3D([2836,2866,2558,2781],0); -ELEMENTS[51744] = Fluid3D([16050,16152,16532,16310],0); -ELEMENTS[51745] = Fluid3D([16532,16050,16310,16168],0); -ELEMENTS[51746] = Fluid3D([16050,16310,16168,15917],0); -ELEMENTS[51747] = Fluid3D([16532,16050,16168,16420],0); -ELEMENTS[51748] = Fluid3D([16548,16964,17008,17185],0); -ELEMENTS[51749] = Fluid3D([10130,9560,9206,9985],0); -ELEMENTS[51750] = Fluid3D([6200,6112,5648,5265],0); -ELEMENTS[51751] = Fluid3D([15248,15076,15868,15580],0); -ELEMENTS[51752] = Fluid3D([6792,7171,6415,6723],0); -ELEMENTS[51753] = Fluid3D([12346,13167,12421,13031],0); -ELEMENTS[51754] = Fluid3D([12421,12346,13031,12186],0); -ELEMENTS[51755] = Fluid3D([8677,9017,8644,7875],0); -ELEMENTS[51756] = Fluid3D([3807,4129,4206,4039],0); -ELEMENTS[51757] = Fluid3D([6817,7202,7635,7927],0); -ELEMENTS[51758] = Fluid3D([16900,17227,16729,16972],0); -ELEMENTS[51759] = Fluid3D([6636,6600,7597,7777],0); -ELEMENTS[51760] = Fluid3D([11681,11591,12089,12801],0); -ELEMENTS[51761] = Fluid3D([14177,14277,13475,13809],0); -ELEMENTS[51762] = Fluid3D([14277,13475,13809,13754],0); -ELEMENTS[51763] = Fluid3D([16515,16600,16108,16194],0); -ELEMENTS[51764] = Fluid3D([1812,1782,1681,1751],0); -ELEMENTS[51765] = Fluid3D([1812,1782,1751,1874],0); -ELEMENTS[51766] = Fluid3D([1751,1812,1874,1887],0); -ELEMENTS[51767] = Fluid3D([1751,1812,1887,1752],0); -ELEMENTS[51768] = Fluid3D([1751,1812,1752,1660],0); -ELEMENTS[51769] = Fluid3D([1887,1751,1752,1728],0); -ELEMENTS[51770] = Fluid3D([1751,1812,1660,1681],0); -ELEMENTS[51771] = Fluid3D([1812,1887,1752,2018],0); -ELEMENTS[51772] = Fluid3D([1752,1751,1660,1728],0); -ELEMENTS[51773] = Fluid3D([1874,1751,1887,1848],0); -ELEMENTS[51774] = Fluid3D([1751,1887,1848,1728],0); -ELEMENTS[51775] = Fluid3D([1887,1874,1848,2047],0); -ELEMENTS[51776] = Fluid3D([1887,1848,1728,1831],0); -ELEMENTS[51777] = Fluid3D([17874,17814,18136,17926],0); -ELEMENTS[51778] = Fluid3D([17814,18136,17926,17991],0); -ELEMENTS[51779] = Fluid3D([17926,17814,17991,17761],0); -ELEMENTS[51780] = Fluid3D([17926,17814,17761,17449],0); -ELEMENTS[51781] = Fluid3D([17874,17814,17926,17623],0); -ELEMENTS[51782] = Fluid3D([17814,17991,17761,17450],0); -ELEMENTS[51783] = Fluid3D([17814,17926,17623,17449],0); -ELEMENTS[51784] = Fluid3D([17814,18136,17991,17818],0); -ELEMENTS[51785] = Fluid3D([17991,17814,17818,17450],0); -ELEMENTS[51786] = Fluid3D([6951,7839,7883,7052],0); -ELEMENTS[51787] = Fluid3D([6951,7839,7052,7511],0); -ELEMENTS[51788] = Fluid3D([7839,7883,7052,7950],0); -ELEMENTS[51789] = Fluid3D([7839,7883,7950,8776],0); -ELEMENTS[51790] = Fluid3D([7839,7883,8776,8492],0); -ELEMENTS[51791] = Fluid3D([6363,6475,6839,6295],0); -ELEMENTS[51792] = Fluid3D([10624,10252,11324,10290],0); -ELEMENTS[51793] = Fluid3D([15442,16088,15814,15849],0); -ELEMENTS[51794] = Fluid3D([14945,15255,14550,14396],0); -ELEMENTS[51795] = Fluid3D([16560,16830,16385,16727],0); -ELEMENTS[51796] = Fluid3D([17211,17159,17502,17071],0); -ELEMENTS[51797] = Fluid3D([5793,5670,5084,5598],0); -ELEMENTS[51798] = Fluid3D([18614,18608,18649,18643],0); -ELEMENTS[51799] = Fluid3D([16454,16410,16074,15655],0); -ELEMENTS[51800] = Fluid3D([14436,14208,13553,14349],0); -ELEMENTS[51801] = Fluid3D([14436,14208,14349,14937],0); -ELEMENTS[51802] = Fluid3D([14349,14436,14937,14936],0); -ELEMENTS[51803] = Fluid3D([14937,14349,14936,14439],0); -ELEMENTS[51804] = Fluid3D([14937,14349,14439,14061],0); -ELEMENTS[51805] = Fluid3D([14349,14439,14061,13596],0); -ELEMENTS[51806] = Fluid3D([14061,14349,13596,14089],0); -ELEMENTS[51807] = Fluid3D([14349,13596,14089,14208],0); -ELEMENTS[51808] = Fluid3D([14439,14061,13596,13611],0); -ELEMENTS[51809] = Fluid3D([14439,14061,13611,13445],0); -ELEMENTS[51810] = Fluid3D([14061,13611,13445,13596],0); -ELEMENTS[51811] = Fluid3D([14089,14349,14208,14937],0); -ELEMENTS[51812] = Fluid3D([13596,14061,14089,14033],0); -ELEMENTS[51813] = Fluid3D([14349,14439,13596,14181],0); -ELEMENTS[51814] = Fluid3D([14349,14439,14181,14936],0); -ELEMENTS[51815] = Fluid3D([13596,14349,14181,13553],0); -ELEMENTS[51816] = Fluid3D([13596,14349,13553,14208],0); -ELEMENTS[51817] = Fluid3D([14349,14181,13553,14436],0); -ELEMENTS[51818] = Fluid3D([14349,14181,14436,14936],0); -ELEMENTS[51819] = Fluid3D([14181,13596,13553,13175],0); -ELEMENTS[51820] = Fluid3D([14089,14349,14937,14061],0); -ELEMENTS[51821] = Fluid3D([14289,14133,14138,14904],0); -ELEMENTS[51822] = Fluid3D([7868,8591,9073,8216],0); -ELEMENTS[51823] = Fluid3D([8591,9073,8216,8073],0); -ELEMENTS[51824] = Fluid3D([4128,3779,3788,4110],0); -ELEMENTS[51825] = Fluid3D([4677,5172,5133,5578],0); -ELEMENTS[51826] = Fluid3D([4377,4016,4488,4628],0); -ELEMENTS[51827] = Fluid3D([4488,4377,4628,5081],0); -ELEMENTS[51828] = Fluid3D([4628,4488,5081,4541],0); -ELEMENTS[51829] = Fluid3D([4628,4488,4541,4016],0); -ELEMENTS[51830] = Fluid3D([5081,4628,4541,5136],0); -ELEMENTS[51831] = Fluid3D([4541,4628,4016,4377],0); -ELEMENTS[51832] = Fluid3D([4628,4541,5136,4946],0); -ELEMENTS[51833] = Fluid3D([4541,4628,4377,4663],0); -ELEMENTS[51834] = Fluid3D([5081,4628,5136,4946],0); -ELEMENTS[51835] = Fluid3D([11619,11308,11821,10398],0); -ELEMENTS[51836] = Fluid3D([2019,2026,1985,2197],0); -ELEMENTS[51837] = Fluid3D([17678,17934,17505,17589],0); -ELEMENTS[51838] = Fluid3D([10059,9859,10123,9341],0); -ELEMENTS[51839] = Fluid3D([9859,10123,9341,9082],0); -ELEMENTS[51840] = Fluid3D([5367,4806,4894,5206],0); -ELEMENTS[51841] = Fluid3D([4806,4894,5206,4361],0); -ELEMENTS[51842] = Fluid3D([4894,5367,5206,5778],0); -ELEMENTS[51843] = Fluid3D([4806,4894,4361,4564],0); -ELEMENTS[51844] = Fluid3D([5206,4894,5778,4923],0); -ELEMENTS[51845] = Fluid3D([5983,5905,6287,5668],0); -ELEMENTS[51846] = Fluid3D([5983,5905,5668,5287],0); -ELEMENTS[51847] = Fluid3D([6287,5983,5668,6059],0); -ELEMENTS[51848] = Fluid3D([5668,5983,5287,5657],0); -ELEMENTS[51849] = Fluid3D([5668,5983,5657,5428],0); -ELEMENTS[51850] = Fluid3D([5983,5668,6059,5428],0); -ELEMENTS[51851] = Fluid3D([10308,9327,10383,10613],0); -ELEMENTS[51852] = Fluid3D([14654,15115,14802,15715],0); -ELEMENTS[51853] = Fluid3D([17280,17480,17609,17639],0); -ELEMENTS[51854] = Fluid3D([9538,9052,9634,10515],0); -ELEMENTS[51855] = Fluid3D([17564,17264,17160,17281],0); -ELEMENTS[51856] = Fluid3D([17564,17264,17281,17309],0); -ELEMENTS[51857] = Fluid3D([17264,17281,17309,16929],0); -ELEMENTS[51858] = Fluid3D([17281,17309,16929,17228],0); -ELEMENTS[51859] = Fluid3D([17264,17281,16929,17160],0); -ELEMENTS[51860] = Fluid3D([17309,17264,16929,16871],0); -ELEMENTS[51861] = Fluid3D([16929,17309,16871,17099],0); -ELEMENTS[51862] = Fluid3D([16929,17309,17099,17228],0); -ELEMENTS[51863] = Fluid3D([17309,16871,17099,17068],0); -ELEMENTS[51864] = Fluid3D([17160,17564,17281,17477],0); -ELEMENTS[51865] = Fluid3D([16871,16929,17099,16456],0); -ELEMENTS[51866] = Fluid3D([16871,16929,16456,16893],0); -ELEMENTS[51867] = Fluid3D([16871,16929,16893,17264],0); -ELEMENTS[51868] = Fluid3D([16929,16893,17264,16591],0); -ELEMENTS[51869] = Fluid3D([14196,13640,13520,13574],0); -ELEMENTS[51870] = Fluid3D([11653,11492,11358,10613],0); -ELEMENTS[51871] = Fluid3D([8653,7931,8410,7558],0); -ELEMENTS[51872] = Fluid3D([11715,11218,11088,10373],0); -ELEMENTS[51873] = Fluid3D([16152,15718,16266,16663],0); -ELEMENTS[51874] = Fluid3D([7005,7448,6664,7329],0); -ELEMENTS[51875] = Fluid3D([5393,5384,5283,5921],0); -ELEMENTS[51876] = Fluid3D([14285,15174,14414,15048],0); -ELEMENTS[51877] = Fluid3D([10288,9906,10525,11134],0); -ELEMENTS[51878] = Fluid3D([5392,6030,5398,5609],0); -ELEMENTS[51879] = Fluid3D([13362,13127,13279,13866],0); -ELEMENTS[51880] = Fluid3D([13279,13362,13866,14166],0); -ELEMENTS[51881] = Fluid3D([13279,13362,14166,13470],0); -ELEMENTS[51882] = Fluid3D([15710,15802,15221,15043],0); -ELEMENTS[51883] = Fluid3D([1723,1641,1727,1712],0); -ELEMENTS[51884] = Fluid3D([3398,3511,3144,3751],0); -ELEMENTS[51885] = Fluid3D([17939,18112,17677,18100],0); -ELEMENTS[51886] = Fluid3D([17295,17071,17502,17156],0); -ELEMENTS[51887] = Fluid3D([17295,17071,17156,16932],0); -ELEMENTS[51888] = Fluid3D([5934,6412,5684,5525],0); -ELEMENTS[51889] = Fluid3D([3098,3065,3080,3669],0); -ELEMENTS[51890] = Fluid3D([17344,17409,17535,17151],0); -ELEMENTS[51891] = Fluid3D([5523,5266,4963,5278],0); -ELEMENTS[51892] = Fluid3D([13273,12769,13896,13797],0); -ELEMENTS[51893] = Fluid3D([13896,13273,13797,13882],0); -ELEMENTS[51894] = Fluid3D([11636,12643,12379,12359],0); -ELEMENTS[51895] = Fluid3D([3983,4051,3950,3601],0); -ELEMENTS[51896] = Fluid3D([3983,4051,3601,3958],0); -ELEMENTS[51897] = Fluid3D([17005,17015,17327,17279],0); -ELEMENTS[51898] = Fluid3D([14357,14005,13628,14694],0); -ELEMENTS[51899] = Fluid3D([9502,9551,10027,10586],0); -ELEMENTS[51900] = Fluid3D([10027,9502,10586,10397],0); -ELEMENTS[51901] = Fluid3D([10586,10027,10397,10520],0); -ELEMENTS[51902] = Fluid3D([10586,10027,10520,10775],0); -ELEMENTS[51903] = Fluid3D([10586,10027,10775,10448],0); -ELEMENTS[51904] = Fluid3D([10586,10027,10448,9974],0); -ELEMENTS[51905] = Fluid3D([10027,10775,10448,9888],0); -ELEMENTS[51906] = Fluid3D([10448,10027,9888,9974],0); -ELEMENTS[51907] = Fluid3D([9888,10448,9974,10403],0); -ELEMENTS[51908] = Fluid3D([10448,9974,10403,11300],0); -ELEMENTS[51909] = Fluid3D([10448,9974,11300,10586],0); -ELEMENTS[51910] = Fluid3D([11300,10448,10586,10775],0); -ELEMENTS[51911] = Fluid3D([11094,11013,11279,10757],0); -ELEMENTS[51912] = Fluid3D([11279,11094,10757,12186],0); -ELEMENTS[51913] = Fluid3D([11013,11279,10757,10679],0); -ELEMENTS[51914] = Fluid3D([11013,11279,10679,11732],0); -ELEMENTS[51915] = Fluid3D([11279,10679,11732,10757],0); -ELEMENTS[51916] = Fluid3D([11732,11279,10757,12186],0); -ELEMENTS[51917] = Fluid3D([9323,9911,10432,10479],0); -ELEMENTS[51918] = Fluid3D([13420,13150,12457,13329],0); -ELEMENTS[51919] = Fluid3D([13420,13150,13329,14282],0); -ELEMENTS[51920] = Fluid3D([8428,9429,9183,9271],0); -ELEMENTS[51921] = Fluid3D([9429,9183,9271,10318],0); -ELEMENTS[51922] = Fluid3D([9183,8428,9271,8205],0); -ELEMENTS[51923] = Fluid3D([9183,8428,8205,8176],0); -ELEMENTS[51924] = Fluid3D([8428,9271,8205,9429],0); -ELEMENTS[51925] = Fluid3D([9083,9852,9532,9464],0); -ELEMENTS[51926] = Fluid3D([15955,16191,16190,15405],0); -ELEMENTS[51927] = Fluid3D([3739,3432,3686,3595],0); -ELEMENTS[51928] = Fluid3D([3647,3613,3437,3335],0); -ELEMENTS[51929] = Fluid3D([10781,9744,9913,10708],0); -ELEMENTS[51930] = Fluid3D([9913,10781,10708,10255],0); -ELEMENTS[51931] = Fluid3D([9913,10781,10255,10678],0); -ELEMENTS[51932] = Fluid3D([10255,9913,10678,9589],0); -ELEMENTS[51933] = Fluid3D([10255,9913,9589,8916],0); -ELEMENTS[51934] = Fluid3D([10678,10255,9589,10674],0); -ELEMENTS[51935] = Fluid3D([10708,9913,10255,10529],0); -ELEMENTS[51936] = Fluid3D([10708,9913,10529,9396],0); -ELEMENTS[51937] = Fluid3D([18507,18594,18564,18626],0); -ELEMENTS[51938] = Fluid3D([10821,10265,10455,9416],0); -ELEMENTS[51939] = Fluid3D([9576,9119,8816,9463],0); -ELEMENTS[51940] = Fluid3D([8133,7762,8710,8623],0); -ELEMENTS[51941] = Fluid3D([13871,13203,14161,13529],0); -ELEMENTS[51942] = Fluid3D([18297,18206,18329,18452],0); -ELEMENTS[51943] = Fluid3D([18329,18297,18452,18470],0); -ELEMENTS[51944] = Fluid3D([16241,16508,16899,16577],0); -ELEMENTS[51945] = Fluid3D([11147,11523,10542,10570],0); -ELEMENTS[51946] = Fluid3D([12083,12165,12968,11495],0); -ELEMENTS[51947] = Fluid3D([9925,10244,10478,9641],0); -ELEMENTS[51948] = Fluid3D([10244,10478,9641,10627],0); -ELEMENTS[51949] = Fluid3D([10478,9641,10627,10021],0); -ELEMENTS[51950] = Fluid3D([10244,10478,10627,11268],0); -ELEMENTS[51951] = Fluid3D([1960,2071,2141,1958],0); -ELEMENTS[51952] = Fluid3D([2071,2141,1958,2018],0); -ELEMENTS[51953] = Fluid3D([1960,2071,1958,1848],0); -ELEMENTS[51954] = Fluid3D([2141,1958,2018,1997],0); -ELEMENTS[51955] = Fluid3D([1958,2018,1997,1831],0); -ELEMENTS[51956] = Fluid3D([1997,1958,1831,1960],0); -ELEMENTS[51957] = Fluid3D([1958,2018,1831,1887],0); -ELEMENTS[51958] = Fluid3D([1958,2018,1887,2047],0); -ELEMENTS[51959] = Fluid3D([1831,1958,1887,1848],0); -ELEMENTS[51960] = Fluid3D([1958,1887,1848,2047],0); -ELEMENTS[51961] = Fluid3D([2141,1958,1997,1960],0); -ELEMENTS[51962] = Fluid3D([1958,1831,1960,1848],0); -ELEMENTS[51963] = Fluid3D([2018,1887,2047,1812],0); -ELEMENTS[51964] = Fluid3D([1958,2071,2018,2047],0); -ELEMENTS[51965] = Fluid3D([18196,18254,17982,18023],0); -ELEMENTS[51966] = Fluid3D([12573,12064,12560,12657],0); -ELEMENTS[51967] = Fluid3D([5441,5564,5035,4893],0); -ELEMENTS[51968] = Fluid3D([13258,12932,12310,12635],0); -ELEMENTS[51969] = Fluid3D([6314,7040,6457,6493],0); -ELEMENTS[51970] = Fluid3D([12487,12022,12983,12548],0); -ELEMENTS[51971] = Fluid3D([7134,7016,7124,6321],0); -ELEMENTS[51972] = Fluid3D([15742,16228,15713,16463],0); -ELEMENTS[51973] = Fluid3D([5802,6194,5430,6046],0); -ELEMENTS[51974] = Fluid3D([18249,18074,17952,18228],0); -ELEMENTS[51975] = Fluid3D([9893,9468,10594,9959],0); -ELEMENTS[51976] = Fluid3D([14871,14653,15204,14585],0); -ELEMENTS[51977] = Fluid3D([14871,15204,14496,14585],0); -ELEMENTS[51978] = Fluid3D([15204,14496,14585,15099],0); -ELEMENTS[51979] = Fluid3D([14585,15204,15099,15369],0); -ELEMENTS[51980] = Fluid3D([13924,14585,14653,14871],0); -ELEMENTS[51981] = Fluid3D([14585,13924,14010,14496],0); -ELEMENTS[51982] = Fluid3D([14010,14585,14496,14462],0); -ELEMENTS[51983] = Fluid3D([14496,14010,14462,13762],0); -ELEMENTS[51984] = Fluid3D([14496,14010,13762,13687],0); -ELEMENTS[51985] = Fluid3D([13924,14010,14496,13687],0); -ELEMENTS[51986] = Fluid3D([14496,14585,15099,14462],0); -ELEMENTS[51987] = Fluid3D([14585,13924,14496,14871],0); -ELEMENTS[51988] = Fluid3D([8433,8723,7825,9188],0); -ELEMENTS[51989] = Fluid3D([13015,12830,13350,12849],0); -ELEMENTS[51990] = Fluid3D([6097,6111,5475,5466],0); -ELEMENTS[51991] = Fluid3D([5475,6097,5466,5455],0); -ELEMENTS[51992] = Fluid3D([5475,6097,5455,5858],0); -ELEMENTS[51993] = Fluid3D([5466,5475,5455,5106],0); -ELEMENTS[51994] = Fluid3D([5475,5455,5106,5858],0); -ELEMENTS[51995] = Fluid3D([16560,16365,16202,15840],0); -ELEMENTS[51996] = Fluid3D([6101,6697,5822,5864],0); -ELEMENTS[51997] = Fluid3D([17917,17837,17991,17450],0); -ELEMENTS[51998] = Fluid3D([11515,10633,11114,10893],0); -ELEMENTS[51999] = Fluid3D([4008,4193,3676,3764],0); -ELEMENTS[52000] = Fluid3D([4008,4193,3764,3874],0); -ELEMENTS[52001] = Fluid3D([14488,14824,15178,15344],0); -ELEMENTS[52002] = Fluid3D([12924,12357,11935,13087],0); -ELEMENTS[52003] = Fluid3D([3783,3873,3646,3351],0); -ELEMENTS[52004] = Fluid3D([2260,2537,2334,2644],0); -ELEMENTS[52005] = Fluid3D([6934,7595,7315,7910],0); -ELEMENTS[52006] = Fluid3D([1881,1705,1823,1789],0); -ELEMENTS[52007] = Fluid3D([1823,1881,1789,1917],0); -ELEMENTS[52008] = Fluid3D([6461,7318,7105,6515],0); -ELEMENTS[52009] = Fluid3D([6461,7318,6515,6893],0); -ELEMENTS[52010] = Fluid3D([14163,14722,15054,14613],0); -ELEMENTS[52011] = Fluid3D([11588,10465,10961,11272],0); -ELEMENTS[52012] = Fluid3D([10465,10961,11272,10502],0); -ELEMENTS[52013] = Fluid3D([10961,11272,10502,11897],0); -ELEMENTS[52014] = Fluid3D([5766,6295,6767,6519],0); -ELEMENTS[52015] = Fluid3D([6416,7023,7312,6741],0); -ELEMENTS[52016] = Fluid3D([10102,10012,9983,9047],0); -ELEMENTS[52017] = Fluid3D([9228,8666,9328,10048],0); -ELEMENTS[52018] = Fluid3D([4282,4128,4110,4768],0); -ELEMENTS[52019] = Fluid3D([7443,6921,7639,7432],0); -ELEMENTS[52020] = Fluid3D([6921,7639,7432,6993],0); -ELEMENTS[52021] = Fluid3D([14131,14769,14066,14539],0); -ELEMENTS[52022] = Fluid3D([15242,15560,15288,15176],0); -ELEMENTS[52023] = Fluid3D([16055,16282,16099,16614],0); -ELEMENTS[52024] = Fluid3D([15964,15706,15904,16271],0); -ELEMENTS[52025] = Fluid3D([6464,7115,7472,6935],0); -ELEMENTS[52026] = Fluid3D([6464,7115,6935,6954],0); -ELEMENTS[52027] = Fluid3D([15552,15290,15940,15902],0); -ELEMENTS[52028] = Fluid3D([15552,15290,15902,15542],0); -ELEMENTS[52029] = Fluid3D([15259,15788,15304,14915],0); -ELEMENTS[52030] = Fluid3D([14126,14803,14257,14246],0); -ELEMENTS[52031] = Fluid3D([5991,5612,6034,5449],0); -ELEMENTS[52032] = Fluid3D([6034,5991,5449,6181],0); -ELEMENTS[52033] = Fluid3D([13487,12788,12872,13781],0); -ELEMENTS[52034] = Fluid3D([12694,13091,13343,12851],0); -ELEMENTS[52035] = Fluid3D([17105,16706,16925,16806],0); -ELEMENTS[52036] = Fluid3D([13487,14057,12788,13781],0); -ELEMENTS[52037] = Fluid3D([13487,14057,13781,14571],0); -ELEMENTS[52038] = Fluid3D([18156,18275,18093,17934],0); -ELEMENTS[52039] = Fluid3D([13044,12755,13557,13928],0); -ELEMENTS[52040] = Fluid3D([2485,2353,2536,2275],0); -ELEMENTS[52041] = Fluid3D([18463,18537,18444,18572],0); -ELEMENTS[52042] = Fluid3D([17023,17098,16740,17109],0); -ELEMENTS[52043] = Fluid3D([3457,3577,3955,3522],0); -ELEMENTS[52044] = Fluid3D([3457,3577,3522,3082],0); -ELEMENTS[52045] = Fluid3D([3522,3457,3082,3208],0); -ELEMENTS[52046] = Fluid3D([3522,3457,3208,3680],0); -ELEMENTS[52047] = Fluid3D([3522,3457,3680,3955],0); -ELEMENTS[52048] = Fluid3D([3577,3955,3522,3505],0); -ELEMENTS[52049] = Fluid3D([14710,14095,14760,14724],0); -ELEMENTS[52050] = Fluid3D([17143,16773,16554,16769],0); -ELEMENTS[52051] = Fluid3D([11610,12346,12186,11732],0); -ELEMENTS[52052] = Fluid3D([12482,12935,12953,11908],0); -ELEMENTS[52053] = Fluid3D([3517,3768,3386,3191],0); -ELEMENTS[52054] = Fluid3D([12110,12698,11668,12203],0); -ELEMENTS[52055] = Fluid3D([15835,16318,16273,16197],0); -ELEMENTS[52056] = Fluid3D([15835,16318,16197,15692],0); -ELEMENTS[52057] = Fluid3D([10551,9546,10466,10501],0); -ELEMENTS[52058] = Fluid3D([2979,2763,2962,3049],0); -ELEMENTS[52059] = Fluid3D([2979,2763,3049,2710],0); -ELEMENTS[52060] = Fluid3D([17675,17424,17462,17270],0); -ELEMENTS[52061] = Fluid3D([17675,17424,17270,16968],0); -ELEMENTS[52062] = Fluid3D([15771,15343,15632,15690],0); -ELEMENTS[52063] = Fluid3D([15632,15771,15690,16183],0); -ELEMENTS[52064] = Fluid3D([15771,15690,16183,16463],0); -ELEMENTS[52065] = Fluid3D([15690,15632,16183,16190],0); -ELEMENTS[52066] = Fluid3D([16183,15690,16190,16339],0); -ELEMENTS[52067] = Fluid3D([15632,15771,16183,16218],0); -ELEMENTS[52068] = Fluid3D([16183,15632,16218,16190],0); -ELEMENTS[52069] = Fluid3D([16218,16183,16190,16758],0); -ELEMENTS[52070] = Fluid3D([16218,16183,16758,16803],0); -ELEMENTS[52071] = Fluid3D([16183,16758,16803,16629],0); -ELEMENTS[52072] = Fluid3D([16758,16803,16629,17137],0); -ELEMENTS[52073] = Fluid3D([16758,16803,17137,17175],0); -ELEMENTS[52074] = Fluid3D([16629,16758,17137,16938],0); -ELEMENTS[52075] = Fluid3D([16758,17137,16938,17175],0); -ELEMENTS[52076] = Fluid3D([16629,16758,16938,16190],0); -ELEMENTS[52077] = Fluid3D([17137,16629,16938,16864],0); -ELEMENTS[52078] = Fluid3D([16629,16938,16864,16190],0); -ELEMENTS[52079] = Fluid3D([16938,17137,16864,17475],0); -ELEMENTS[52080] = Fluid3D([16938,17137,17475,17175],0); -ELEMENTS[52081] = Fluid3D([17137,17475,17175,17308],0); -ELEMENTS[52082] = Fluid3D([17137,17475,17308,16803],0); -ELEMENTS[52083] = Fluid3D([16758,16803,17175,16959],0); -ELEMENTS[52084] = Fluid3D([16758,16803,16959,16218],0); -ELEMENTS[52085] = Fluid3D([16803,16629,17137,17212],0); -ELEMENTS[52086] = Fluid3D([17137,16629,16864,17212],0); -ELEMENTS[52087] = Fluid3D([16938,16758,17175,17006],0); -ELEMENTS[52088] = Fluid3D([16758,17175,17006,16959],0); -ELEMENTS[52089] = Fluid3D([16938,16758,17006,16649],0); -ELEMENTS[52090] = Fluid3D([17175,16938,17006,17165],0); -ELEMENTS[52091] = Fluid3D([16938,17006,17165,16649],0); -ELEMENTS[52092] = Fluid3D([17165,16938,16649,16864],0); -ELEMENTS[52093] = Fluid3D([17006,17175,17165,17451],0); -ELEMENTS[52094] = Fluid3D([17165,16938,16864,17475],0); -ELEMENTS[52095] = Fluid3D([16938,16649,16864,16190],0); -ELEMENTS[52096] = Fluid3D([17175,16938,17165,17475],0); -ELEMENTS[52097] = Fluid3D([17175,17137,17308,16803],0); -ELEMENTS[52098] = Fluid3D([16938,16758,16649,16190],0); -ELEMENTS[52099] = Fluid3D([17137,17475,16803,17212],0); -ELEMENTS[52100] = Fluid3D([17137,17475,17212,16864],0); -ELEMENTS[52101] = Fluid3D([16629,16864,17212,16463],0); -ELEMENTS[52102] = Fluid3D([16629,16864,16463,16339],0); -ELEMENTS[52103] = Fluid3D([16463,16629,16339,16183],0); -ELEMENTS[52104] = Fluid3D([17165,17006,17451,17315],0); -ELEMENTS[52105] = Fluid3D([17165,17006,17315,16695],0); -ELEMENTS[52106] = Fluid3D([17451,17165,17315,17269],0); -ELEMENTS[52107] = Fluid3D([17165,17315,17269,17003],0); -ELEMENTS[52108] = Fluid3D([16463,16629,16183,16803],0); -ELEMENTS[52109] = Fluid3D([16463,16629,16803,17212],0); -ELEMENTS[52110] = Fluid3D([16183,16758,16629,16190],0); -ELEMENTS[52111] = Fluid3D([16629,16183,16190,16339],0); -ELEMENTS[52112] = Fluid3D([16629,16864,16339,16190],0); -ELEMENTS[52113] = Fluid3D([8006,7926,8935,8702],0); -ELEMENTS[52114] = Fluid3D([16274,16019,16380,16624],0); -ELEMENTS[52115] = Fluid3D([16019,16380,16624,16142],0); -ELEMENTS[52116] = Fluid3D([16380,16624,16142,16363],0); -ELEMENTS[52117] = Fluid3D([16624,16142,16363,16313],0); -ELEMENTS[52118] = Fluid3D([16142,16363,16313,15789],0); -ELEMENTS[52119] = Fluid3D([16313,16142,15789,16019],0); -ELEMENTS[52120] = Fluid3D([16142,16363,15789,15579],0); -ELEMENTS[52121] = Fluid3D([16142,16380,16363,15841],0); -ELEMENTS[52122] = Fluid3D([16142,16380,15841,16019],0); -ELEMENTS[52123] = Fluid3D([15789,16142,15579,15841],0); -ELEMENTS[52124] = Fluid3D([15789,16142,15841,16019],0); -ELEMENTS[52125] = Fluid3D([16624,16142,16313,16019],0); -ELEMENTS[52126] = Fluid3D([16380,16624,16363,16818],0); -ELEMENTS[52127] = Fluid3D([16363,16142,15841,15579],0); -ELEMENTS[52128] = Fluid3D([5558,5473,5135,5397],0); -ELEMENTS[52129] = Fluid3D([5558,5473,5397,5704],0); -ELEMENTS[52130] = Fluid3D([5473,5397,5704,6183],0); -ELEMENTS[52131] = Fluid3D([4837,4698,4617,5214],0); -ELEMENTS[52132] = Fluid3D([4837,4698,5214,5322],0); -ELEMENTS[52133] = Fluid3D([11832,10896,11609,11544],0); -ELEMENTS[52134] = Fluid3D([15300,15465,14758,15405],0); -ELEMENTS[52135] = Fluid3D([5737,5096,5744,5219],0); -ELEMENTS[52136] = Fluid3D([6917,7293,6460,7420],0); -ELEMENTS[52137] = Fluid3D([6460,6917,7420,6934],0); -ELEMENTS[52138] = Fluid3D([6460,6917,6934,6838],0); -ELEMENTS[52139] = Fluid3D([6917,7293,7420,7910],0); -ELEMENTS[52140] = Fluid3D([13638,13378,12903,13890],0); -ELEMENTS[52141] = Fluid3D([13378,12903,13890,13650],0); -ELEMENTS[52142] = Fluid3D([17529,17680,17611,17861],0); -ELEMENTS[52143] = Fluid3D([17529,17680,17861,17916],0); -ELEMENTS[52144] = Fluid3D([17529,17680,17916,17742],0); -ELEMENTS[52145] = Fluid3D([7593,7858,8042,8622],0); -ELEMENTS[52146] = Fluid3D([8042,7593,8622,8075],0); -ELEMENTS[52147] = Fluid3D([8042,7593,8075,7360],0); -ELEMENTS[52148] = Fluid3D([8042,7593,7360,6987],0); -ELEMENTS[52149] = Fluid3D([7593,8075,7360,7015],0); -ELEMENTS[52150] = Fluid3D([8075,8042,7360,8794],0); -ELEMENTS[52151] = Fluid3D([8075,8042,8794,8622],0); -ELEMENTS[52152] = Fluid3D([7593,7858,8622,7731],0); -ELEMENTS[52153] = Fluid3D([15081,15644,15563,16066],0); -ELEMENTS[52154] = Fluid3D([17748,17650,17876,18097],0); -ELEMENTS[52155] = Fluid3D([4796,5135,5371,5122],0); -ELEMENTS[52156] = Fluid3D([4796,5135,5122,4571],0); -ELEMENTS[52157] = Fluid3D([5135,5122,4571,5065],0); -ELEMENTS[52158] = Fluid3D([4796,5135,4571,4804],0); -ELEMENTS[52159] = Fluid3D([5135,5371,5122,5558],0); -ELEMENTS[52160] = Fluid3D([15748,16061,15554,15471],0); -ELEMENTS[52161] = Fluid3D([15748,16061,15471,15994],0); -ELEMENTS[52162] = Fluid3D([15748,16061,15994,16516],0); -ELEMENTS[52163] = Fluid3D([12370,13452,12991,13209],0); -ELEMENTS[52164] = Fluid3D([14287,14711,14381,13622],0); -ELEMENTS[52165] = Fluid3D([11743,12190,11665,11030],0); -ELEMENTS[52166] = Fluid3D([10464,9276,9906,10524],0); -ELEMENTS[52167] = Fluid3D([17578,17749,17350,17338],0); -ELEMENTS[52168] = Fluid3D([11849,12191,11587,11039],0); -ELEMENTS[52169] = Fluid3D([12191,11587,11039,12160],0); -ELEMENTS[52170] = Fluid3D([12495,13405,13400,12973],0); -ELEMENTS[52171] = Fluid3D([14911,14382,15335,14940],0); -ELEMENTS[52172] = Fluid3D([6492,6652,7286,6525],0); -ELEMENTS[52173] = Fluid3D([8049,7390,8219,7568],0); -ELEMENTS[52174] = Fluid3D([14576,15114,15375,15057],0); -ELEMENTS[52175] = Fluid3D([14786,15208,15498,15662],0); -ELEMENTS[52176] = Fluid3D([4495,4615,5043,4805],0); -ELEMENTS[52177] = Fluid3D([8181,7832,8054,9107],0); -ELEMENTS[52178] = Fluid3D([4538,4459,4641,3879],0); -ELEMENTS[52179] = Fluid3D([3933,4280,4422,4769],0); -ELEMENTS[52180] = Fluid3D([9120,9959,9061,9766],0); -ELEMENTS[52181] = Fluid3D([4287,4377,3917,4315],0); -ELEMENTS[52182] = Fluid3D([4377,3917,4315,4186],0); -ELEMENTS[52183] = Fluid3D([5318,5854,5323,5929],0); -ELEMENTS[52184] = Fluid3D([12733,12459,13297,13141],0); -ELEMENTS[52185] = Fluid3D([17383,17268,17177,17314],0); -ELEMENTS[52186] = Fluid3D([17268,17177,17314,16915],0); -ELEMENTS[52187] = Fluid3D([17314,17268,16915,16951],0); -ELEMENTS[52188] = Fluid3D([17314,17268,16951,17351],0); -ELEMENTS[52189] = Fluid3D([17314,17268,17351,17662],0); -ELEMENTS[52190] = Fluid3D([17314,17268,17662,17383],0); -ELEMENTS[52191] = Fluid3D([14699,15192,15158,14611],0); -ELEMENTS[52192] = Fluid3D([6599,6762,6552,5791],0); -ELEMENTS[52193] = Fluid3D([4669,4386,4800,5158],0); -ELEMENTS[52194] = Fluid3D([15737,16171,15715,16327],0); -ELEMENTS[52195] = Fluid3D([13680,13633,12843,12500],0); -ELEMENTS[52196] = Fluid3D([15274,14847,15719,15428],0); -ELEMENTS[52197] = Fluid3D([15274,14847,15428,14987],0); -ELEMENTS[52198] = Fluid3D([15428,15274,14987,15957],0); -ELEMENTS[52199] = Fluid3D([8142,8180,7477,7238],0); -ELEMENTS[52200] = Fluid3D([16665,16455,16033,15987],0); -ELEMENTS[52201] = Fluid3D([16665,16455,15987,16566],0); -ELEMENTS[52202] = Fluid3D([6979,7185,7889,6926],0); -ELEMENTS[52203] = Fluid3D([6979,7185,6926,6178],0); -ELEMENTS[52204] = Fluid3D([13855,13036,13870,13431],0); -ELEMENTS[52205] = Fluid3D([4421,4166,4560,4758],0); -ELEMENTS[52206] = Fluid3D([11629,11988,12046,10806],0); -ELEMENTS[52207] = Fluid3D([8759,8055,8076,7696],0); -ELEMENTS[52208] = Fluid3D([8055,8076,7696,7188],0); -ELEMENTS[52209] = Fluid3D([7696,8055,7188,7873],0); -ELEMENTS[52210] = Fluid3D([7188,7696,7873,7112],0); -ELEMENTS[52211] = Fluid3D([7696,7873,7112,8106],0); -ELEMENTS[52212] = Fluid3D([7696,7873,8106,8759],0); -ELEMENTS[52213] = Fluid3D([7188,7696,7112,7079],0); -ELEMENTS[52214] = Fluid3D([7112,7696,8106,7803],0); -ELEMENTS[52215] = Fluid3D([8106,7112,7803,7921],0); -ELEMENTS[52216] = Fluid3D([7803,8106,7921,8756],0); -ELEMENTS[52217] = Fluid3D([7803,8106,8756,8076],0); -ELEMENTS[52218] = Fluid3D([7696,8106,7803,8076],0); -ELEMENTS[52219] = Fluid3D([7696,7873,8759,8055],0); -ELEMENTS[52220] = Fluid3D([7873,7112,8106,8503],0); -ELEMENTS[52221] = Fluid3D([8106,7873,8503,8759],0); -ELEMENTS[52222] = Fluid3D([7112,7696,7803,7079],0); -ELEMENTS[52223] = Fluid3D([8106,7696,8759,8076],0); -ELEMENTS[52224] = Fluid3D([8503,8106,8759,8756],0); -ELEMENTS[52225] = Fluid3D([8503,8106,8756,7921],0); -ELEMENTS[52226] = Fluid3D([8503,8106,7921,7112],0); -ELEMENTS[52227] = Fluid3D([7873,7188,7112,7353],0); -ELEMENTS[52228] = Fluid3D([7554,8444,7680,7828],0); -ELEMENTS[52229] = Fluid3D([15449,15157,15304,14711],0); -ELEMENTS[52230] = Fluid3D([18187,17920,18209,18073],0); -ELEMENTS[52231] = Fluid3D([10221,9120,9629,9712],0); -ELEMENTS[52232] = Fluid3D([18019,18170,18283,18108],0); -ELEMENTS[52233] = Fluid3D([10514,10488,10895,10056],0); -ELEMENTS[52234] = Fluid3D([9818,10447,9588,9936],0); -ELEMENTS[52235] = Fluid3D([10447,9588,9936,10488],0); -ELEMENTS[52236] = Fluid3D([13625,12955,13077,12846],0); -ELEMENTS[52237] = Fluid3D([12955,13077,12846,11739],0); -ELEMENTS[52238] = Fluid3D([13625,12955,12846,12310],0); -ELEMENTS[52239] = Fluid3D([12955,12846,12310,11739],0); -ELEMENTS[52240] = Fluid3D([5229,5824,5566,6185],0); -ELEMENTS[52241] = Fluid3D([4822,4499,4734,4957],0); -ELEMENTS[52242] = Fluid3D([4822,4499,4957,4306],0); -ELEMENTS[52243] = Fluid3D([7742,7650,8405,8596],0); -ELEMENTS[52244] = Fluid3D([7742,7650,8596,7502],0); -ELEMENTS[52245] = Fluid3D([5583,5757,6013,5464],0); -ELEMENTS[52246] = Fluid3D([6013,5583,5464,5674],0); -ELEMENTS[52247] = Fluid3D([6013,5583,5674,6134],0); -ELEMENTS[52248] = Fluid3D([5583,5464,5674,5047],0); -ELEMENTS[52249] = Fluid3D([5674,5583,5047,4731],0); -ELEMENTS[52250] = Fluid3D([12936,13091,12851,14197],0); -ELEMENTS[52251] = Fluid3D([15681,15105,15469,15475],0); -ELEMENTS[52252] = Fluid3D([12715,13182,13091,13905],0); -ELEMENTS[52253] = Fluid3D([17313,17664,17563,17727],0); -ELEMENTS[52254] = Fluid3D([11567,11610,10551,11229],0); -ELEMENTS[52255] = Fluid3D([8807,8076,8056,8756],0); -ELEMENTS[52256] = Fluid3D([9382,8771,8418,9687],0); -ELEMENTS[52257] = Fluid3D([7411,6606,7032,6376],0); -ELEMENTS[52258] = Fluid3D([11755,12585,12222,12785],0); -ELEMENTS[52259] = Fluid3D([12141,10970,11693,11387],0); -ELEMENTS[52260] = Fluid3D([18169,18320,18291,18017],0); -ELEMENTS[52261] = Fluid3D([15247,14939,14487,15196],0); -ELEMENTS[52262] = Fluid3D([6815,6591,6776,6617],0); -ELEMENTS[52263] = Fluid3D([10749,9960,11374,10454],0); -ELEMENTS[52264] = Fluid3D([11374,10749,10454,10541],0); -ELEMENTS[52265] = Fluid3D([11374,10749,10541,11866],0); -ELEMENTS[52266] = Fluid3D([11374,10749,11866,11575],0); -ELEMENTS[52267] = Fluid3D([11374,10749,11575,10440],0); -ELEMENTS[52268] = Fluid3D([16005,16301,16195,16651],0); -ELEMENTS[52269] = Fluid3D([10289,9941,10408,10964],0); -ELEMENTS[52270] = Fluid3D([10289,9941,10964,10544],0); -ELEMENTS[52271] = Fluid3D([7762,6693,7146,7346],0); -ELEMENTS[52272] = Fluid3D([15074,15746,15050,15589],0); -ELEMENTS[52273] = Fluid3D([8512,7675,8052,7610],0); -ELEMENTS[52274] = Fluid3D([6237,6980,6959,6803],0); -ELEMENTS[52275] = Fluid3D([12495,12125,11837,12160],0); -ELEMENTS[52276] = Fluid3D([12495,12125,12160,12191],0); -ELEMENTS[52277] = Fluid3D([12160,12495,12191,12973],0); -ELEMENTS[52278] = Fluid3D([12160,12495,12973,13006],0); -ELEMENTS[52279] = Fluid3D([12160,12495,13006,12315],0); -ELEMENTS[52280] = Fluid3D([9963,11013,10757,10679],0); -ELEMENTS[52281] = Fluid3D([8104,7892,8889,8330],0); -ELEMENTS[52282] = Fluid3D([11784,11990,12225,12716],0); -ELEMENTS[52283] = Fluid3D([11784,11990,12716,11785],0); -ELEMENTS[52284] = Fluid3D([11990,12225,12716,12628],0); -ELEMENTS[52285] = Fluid3D([12716,11990,12628,13104],0); -ELEMENTS[52286] = Fluid3D([11990,12225,12628,12143],0); -ELEMENTS[52287] = Fluid3D([16209,16637,16133,16427],0); -ELEMENTS[52288] = Fluid3D([16637,16133,16427,16813],0); -ELEMENTS[52289] = Fluid3D([17622,17483,17267,17011],0); -ELEMENTS[52290] = Fluid3D([2869,2844,2734,2454],0); -ELEMENTS[52291] = Fluid3D([9395,10077,9230,9819],0); -ELEMENTS[52292] = Fluid3D([9395,10077,9819,10618],0); -ELEMENTS[52293] = Fluid3D([9395,10077,10618,10031],0); -ELEMENTS[52294] = Fluid3D([10369,9384,9329,10005],0); -ELEMENTS[52295] = Fluid3D([13608,14034,14378,13537],0); -ELEMENTS[52296] = Fluid3D([13608,14034,13537,12870],0); -ELEMENTS[52297] = Fluid3D([13537,13608,12870,13183],0); -ELEMENTS[52298] = Fluid3D([13608,12870,13183,13011],0); -ELEMENTS[52299] = Fluid3D([13183,13608,13011,13877],0); -ELEMENTS[52300] = Fluid3D([13183,13608,13877,13537],0); -ELEMENTS[52301] = Fluid3D([13608,13011,13877,14131],0); -ELEMENTS[52302] = Fluid3D([11665,12431,12567,11743],0); -ELEMENTS[52303] = Fluid3D([7898,7509,8552,7706],0); -ELEMENTS[52304] = Fluid3D([1728,1887,1831,1752],0); -ELEMENTS[52305] = Fluid3D([1831,1728,1752,1727],0); -ELEMENTS[52306] = Fluid3D([1752,1831,1727,1888],0); -ELEMENTS[52307] = Fluid3D([1727,1752,1888,1807],0); -ELEMENTS[52308] = Fluid3D([1887,1831,1752,2018],0); -ELEMENTS[52309] = Fluid3D([14351,13943,14808,14460],0); -ELEMENTS[52310] = Fluid3D([13943,14808,14460,14241],0); -ELEMENTS[52311] = Fluid3D([10148,9754,9216,10659],0); -ELEMENTS[52312] = Fluid3D([10148,9754,10659,11382],0); -ELEMENTS[52313] = Fluid3D([3764,4008,3874,3676],0); -ELEMENTS[52314] = Fluid3D([18280,18436,18547,18474],0); -ELEMENTS[52315] = Fluid3D([10212,9448,9596,9656],0); -ELEMENTS[52316] = Fluid3D([13262,14074,12948,13601],0); -ELEMENTS[52317] = Fluid3D([11781,11896,12669,11927],0); -ELEMENTS[52318] = Fluid3D([13459,13362,14121,13866],0); -ELEMENTS[52319] = Fluid3D([14702,13746,14636,14461],0); -ELEMENTS[52320] = Fluid3D([3699,3420,3223,3873],0); -ELEMENTS[52321] = Fluid3D([16727,17116,16560,16830],0); -ELEMENTS[52322] = Fluid3D([6336,6152,5603,5974],0); -ELEMENTS[52323] = Fluid3D([14000,14452,13766,13519],0); -ELEMENTS[52324] = Fluid3D([13766,14000,13519,12826],0); -ELEMENTS[52325] = Fluid3D([13519,13766,12826,13243],0); -ELEMENTS[52326] = Fluid3D([12826,13519,13243,13667],0); -ELEMENTS[52327] = Fluid3D([12826,13519,13667,13404],0); -ELEMENTS[52328] = Fluid3D([13519,13243,13667,14452],0); -ELEMENTS[52329] = Fluid3D([14000,14452,13519,13667],0); -ELEMENTS[52330] = Fluid3D([13519,14000,13667,13404],0); -ELEMENTS[52331] = Fluid3D([13519,14000,13404,12826],0); -ELEMENTS[52332] = Fluid3D([13519,13766,13243,14452],0); -ELEMENTS[52333] = Fluid3D([12553,13004,13158,11987],0); -ELEMENTS[52334] = Fluid3D([13001,13716,13140,13964],0); -ELEMENTS[52335] = Fluid3D([13001,13716,13964,14105],0); -ELEMENTS[52336] = Fluid3D([13716,13140,13964,13484],0); -ELEMENTS[52337] = Fluid3D([2674,2507,2391,2518],0); -ELEMENTS[52338] = Fluid3D([14663,14898,14990,15310],0); -ELEMENTS[52339] = Fluid3D([14663,14898,15310,15620],0); -ELEMENTS[52340] = Fluid3D([14898,14990,15310,15620],0); -ELEMENTS[52341] = Fluid3D([18344,18237,18048,18352],0); -ELEMENTS[52342] = Fluid3D([4989,4758,4421,4560],0); -ELEMENTS[52343] = Fluid3D([8772,8444,8022,7554],0); -ELEMENTS[52344] = Fluid3D([13271,12736,12409,13892],0); -ELEMENTS[52345] = Fluid3D([16780,16923,16596,16870],0); -ELEMENTS[52346] = Fluid3D([8291,7266,7392,7629],0); -ELEMENTS[52347] = Fluid3D([14060,13949,13699,14476],0); -ELEMENTS[52348] = Fluid3D([7193,7272,6388,7024],0); -ELEMENTS[52349] = Fluid3D([14443,14464,14415,13406],0); -ELEMENTS[52350] = Fluid3D([13246,13671,12996,13765],0); -ELEMENTS[52351] = Fluid3D([15538,15455,14799,14867],0); -ELEMENTS[52352] = Fluid3D([14102,13891,14595,14943],0); -ELEMENTS[52353] = Fluid3D([14654,14452,14142,13884],0); -ELEMENTS[52354] = Fluid3D([16741,17036,17234,16892],0); -ELEMENTS[52355] = Fluid3D([17036,17234,16892,17096],0); -ELEMENTS[52356] = Fluid3D([16741,17036,16892,16311],0); -ELEMENTS[52357] = Fluid3D([17234,16892,17096,17246],0); -ELEMENTS[52358] = Fluid3D([17234,16741,16892,17048],0); -ELEMENTS[52359] = Fluid3D([16892,17234,17048,16835],0); -ELEMENTS[52360] = Fluid3D([16892,17234,16835,17246],0); -ELEMENTS[52361] = Fluid3D([2291,2134,2066,2229],0); -ELEMENTS[52362] = Fluid3D([14183,13602,14473,14279],0); -ELEMENTS[52363] = Fluid3D([16701,16397,16161,16326],0); -ELEMENTS[52364] = Fluid3D([16701,16397,16326,16837],0); -ELEMENTS[52365] = Fluid3D([4361,4087,4350,4564],0); -ELEMENTS[52366] = Fluid3D([6509,6805,6953,6284],0); -ELEMENTS[52367] = Fluid3D([6509,6805,6284,6181],0); -ELEMENTS[52368] = Fluid3D([6953,6509,6284,6302],0); -ELEMENTS[52369] = Fluid3D([6284,6509,6181,5754],0); -ELEMENTS[52370] = Fluid3D([6284,6509,5754,6302],0); -ELEMENTS[52371] = Fluid3D([13759,13741,14603,13947],0); -ELEMENTS[52372] = Fluid3D([13759,13741,13947,13064],0); -ELEMENTS[52373] = Fluid3D([15693,15486,15665,14832],0); -ELEMENTS[52374] = Fluid3D([17426,17412,17577,17837],0); -ELEMENTS[52375] = Fluid3D([3583,3754,3762,3864],0); -ELEMENTS[52376] = Fluid3D([3754,3762,3864,4250],0); -ELEMENTS[52377] = Fluid3D([3754,3762,4250,3905],0); -ELEMENTS[52378] = Fluid3D([5364,5834,5428,5922],0); -ELEMENTS[52379] = Fluid3D([5364,5834,5922,5863],0); -ELEMENTS[52380] = Fluid3D([5922,5364,5863,5299],0); -ELEMENTS[52381] = Fluid3D([5834,5922,5863,6682],0); -ELEMENTS[52382] = Fluid3D([8898,8906,9883,9380],0); -ELEMENTS[52383] = Fluid3D([8898,8906,9380,8662],0); -ELEMENTS[52384] = Fluid3D([14210,14463,14902,15082],0); -ELEMENTS[52385] = Fluid3D([11203,11914,11714,10702],0); -ELEMENTS[52386] = Fluid3D([5731,5718,5537,5223],0); -ELEMENTS[52387] = Fluid3D([11935,12357,12197,13087],0); -ELEMENTS[52388] = Fluid3D([7061,7740,8209,7734],0); -ELEMENTS[52389] = Fluid3D([7740,8209,7734,8734],0); -ELEMENTS[52390] = Fluid3D([7061,7740,7734,6714],0); -ELEMENTS[52391] = Fluid3D([8651,8080,7537,8370],0); -ELEMENTS[52392] = Fluid3D([16117,16585,16516,16800],0); -ELEMENTS[52393] = Fluid3D([13071,12389,13224,12427],0); -ELEMENTS[52394] = Fluid3D([4849,4411,4469,4903],0); -ELEMENTS[52395] = Fluid3D([4849,4411,4903,4835],0); -ELEMENTS[52396] = Fluid3D([3678,3776,4059,3468],0); -ELEMENTS[52397] = Fluid3D([3678,3776,3468,3094],0); -ELEMENTS[52398] = Fluid3D([15385,15244,15399,14704],0); -ELEMENTS[52399] = Fluid3D([15526,15634,15822,15563],0); -ELEMENTS[52400] = Fluid3D([15634,15822,15563,16207],0); -ELEMENTS[52401] = Fluid3D([18109,18275,17934,18093],0); -ELEMENTS[52402] = Fluid3D([8885,9588,9936,8477],0); -ELEMENTS[52403] = Fluid3D([9588,9936,8477,9333],0); -ELEMENTS[52404] = Fluid3D([9588,9936,9333,9818],0); -ELEMENTS[52405] = Fluid3D([9333,9588,9818,8926],0); -ELEMENTS[52406] = Fluid3D([9818,9333,8926,9697],0); -ELEMENTS[52407] = Fluid3D([9818,9333,9697,9936],0); -ELEMENTS[52408] = Fluid3D([9333,9588,8926,8477],0); -ELEMENTS[52409] = Fluid3D([8926,9333,8477,8452],0); -ELEMENTS[52410] = Fluid3D([8926,9333,8452,9697],0); -ELEMENTS[52411] = Fluid3D([8885,9588,8477,8926],0); -ELEMENTS[52412] = Fluid3D([9904,9244,10284,9556],0); -ELEMENTS[52413] = Fluid3D([17329,17269,17165,17451],0); -ELEMENTS[52414] = Fluid3D([15106,15419,14661,15234],0); -ELEMENTS[52415] = Fluid3D([14567,14874,15151,14378],0); -ELEMENTS[52416] = Fluid3D([15151,14567,14378,14736],0); -ELEMENTS[52417] = Fluid3D([15151,14567,14736,15447],0); -ELEMENTS[52418] = Fluid3D([14567,14378,14736,13877],0); -ELEMENTS[52419] = Fluid3D([14567,14378,13877,14874],0); -ELEMENTS[52420] = Fluid3D([15879,15393,15874,15902],0); -ELEMENTS[52421] = Fluid3D([9581,9501,10500,10298],0); -ELEMENTS[52422] = Fluid3D([17407,17226,17583,17682],0); -ELEMENTS[52423] = Fluid3D([3922,3483,3820,3430],0); -ELEMENTS[52424] = Fluid3D([3922,3483,3430,3508],0); -ELEMENTS[52425] = Fluid3D([8808,7871,7786,8389],0); -ELEMENTS[52426] = Fluid3D([16431,16151,16098,16125],0); -ELEMENTS[52427] = Fluid3D([16431,16151,16125,15806],0); -ELEMENTS[52428] = Fluid3D([6960,6251,6306,7087],0); -ELEMENTS[52429] = Fluid3D([18228,18018,18216,18202],0); -ELEMENTS[52430] = Fluid3D([11234,11460,10541,11866],0); -ELEMENTS[52431] = Fluid3D([11234,11460,11866,12282],0); -ELEMENTS[52432] = Fluid3D([4956,4851,4875,5394],0); -ELEMENTS[52433] = Fluid3D([4851,4875,5394,5438],0); -ELEMENTS[52434] = Fluid3D([4875,4956,5394,5137],0); -ELEMENTS[52435] = Fluid3D([5394,4875,5137,5304],0); -ELEMENTS[52436] = Fluid3D([4875,4956,5137,4839],0); -ELEMENTS[52437] = Fluid3D([4956,5394,5137,5544],0); -ELEMENTS[52438] = Fluid3D([5394,5137,5544,5485],0); -ELEMENTS[52439] = Fluid3D([5137,5544,5485,5537],0); -ELEMENTS[52440] = Fluid3D([5137,4956,5544,5537],0); -ELEMENTS[52441] = Fluid3D([4956,5544,5537,5369],0); -ELEMENTS[52442] = Fluid3D([4875,5394,5438,5304],0); -ELEMENTS[52443] = Fluid3D([4956,5394,5544,5711],0); -ELEMENTS[52444] = Fluid3D([5394,5544,5711,5821],0); -ELEMENTS[52445] = Fluid3D([5394,5137,5485,5304],0); -ELEMENTS[52446] = Fluid3D([5137,5485,5304,4839],0); -ELEMENTS[52447] = Fluid3D([5137,5485,4839,5126],0); -ELEMENTS[52448] = Fluid3D([5137,5485,5126,5532],0); -ELEMENTS[52449] = Fluid3D([4839,5137,5126,4956],0); -ELEMENTS[52450] = Fluid3D([5126,5137,5532,4956],0); -ELEMENTS[52451] = Fluid3D([5485,5126,5532,4976],0); -ELEMENTS[52452] = Fluid3D([5126,5532,4976,4956],0); -ELEMENTS[52453] = Fluid3D([5485,5126,4976,4839],0); -ELEMENTS[52454] = Fluid3D([5126,4976,4839,4567],0); -ELEMENTS[52455] = Fluid3D([5126,4976,4567,4956],0); -ELEMENTS[52456] = Fluid3D([4839,5126,4567,4956],0); -ELEMENTS[52457] = Fluid3D([4976,4839,4567,4506],0); -ELEMENTS[52458] = Fluid3D([4875,5137,5304,4777],0); -ELEMENTS[52459] = Fluid3D([5137,5485,5532,5537],0); -ELEMENTS[52460] = Fluid3D([2925,3367,3224,2938],0); -ELEMENTS[52461] = Fluid3D([13248,14011,13370,13734],0); -ELEMENTS[52462] = Fluid3D([13248,14011,13734,13256],0); -ELEMENTS[52463] = Fluid3D([11735,11422,11287,12228],0); -ELEMENTS[52464] = Fluid3D([12900,13134,13613,12921],0); -ELEMENTS[52465] = Fluid3D([6151,5775,5424,5930],0); -ELEMENTS[52466] = Fluid3D([18362,18208,18276,18313],0); -ELEMENTS[52467] = Fluid3D([18276,18362,18313,18480],0); -ELEMENTS[52468] = Fluid3D([18276,18362,18480,18363],0); -ELEMENTS[52469] = Fluid3D([16113,15705,16334,16006],0); -ELEMENTS[52470] = Fluid3D([15648,15413,15360,15931],0); -ELEMENTS[52471] = Fluid3D([15648,15413,15931,15209],0); -ELEMENTS[52472] = Fluid3D([8311,8790,9471,8981],0); -ELEMENTS[52473] = Fluid3D([14067,14011,13248,13669],0); -ELEMENTS[52474] = Fluid3D([4139,4471,4367,4000],0); -ELEMENTS[52475] = Fluid3D([4139,4471,4000,4482],0); -ELEMENTS[52476] = Fluid3D([4000,4139,4482,4103],0); -ELEMENTS[52477] = Fluid3D([4000,4139,4103,3745],0); -ELEMENTS[52478] = Fluid3D([4000,4139,3745,3503],0); -ELEMENTS[52479] = Fluid3D([4139,4103,3745,4176],0); -ELEMENTS[52480] = Fluid3D([4153,4322,4425,4832],0); -ELEMENTS[52481] = Fluid3D([10304,10404,9187,9090],0); -ELEMENTS[52482] = Fluid3D([7459,7483,6969,6643],0); -ELEMENTS[52483] = Fluid3D([7459,7483,6643,7442],0); -ELEMENTS[52484] = Fluid3D([4643,4718,4466,4779],0); -ELEMENTS[52485] = Fluid3D([13076,12468,13585,13575],0); -ELEMENTS[52486] = Fluid3D([13585,13076,13575,14018],0); -ELEMENTS[52487] = Fluid3D([13585,13076,14018,13658],0); -ELEMENTS[52488] = Fluid3D([13585,13076,13658,12876],0); -ELEMENTS[52489] = Fluid3D([13076,13658,12876,14075],0); -ELEMENTS[52490] = Fluid3D([13658,12876,14075,13633],0); -ELEMENTS[52491] = Fluid3D([14075,13658,13633,14147],0); -ELEMENTS[52492] = Fluid3D([14075,13658,14147,14018],0); -ELEMENTS[52493] = Fluid3D([14075,13658,14018,13076],0); -ELEMENTS[52494] = Fluid3D([14018,13585,13658,14147],0); -ELEMENTS[52495] = Fluid3D([13585,13658,14147,12876],0); -ELEMENTS[52496] = Fluid3D([13575,13585,14018,14393],0); -ELEMENTS[52497] = Fluid3D([14014,14580,14608,15046],0); -ELEMENTS[52498] = Fluid3D([14580,14608,15046,15065],0); -ELEMENTS[52499] = Fluid3D([9148,9295,9470,10390],0); -ELEMENTS[52500] = Fluid3D([5037,5385,5133,4737],0); -ELEMENTS[52501] = Fluid3D([5037,5385,4737,4637],0); -ELEMENTS[52502] = Fluid3D([18451,18333,18332,18472],0); -ELEMENTS[52503] = Fluid3D([18333,18332,18472,18252],0); -ELEMENTS[52504] = Fluid3D([18332,18451,18472,18484],0); -ELEMENTS[52505] = Fluid3D([18472,18332,18484,18328],0); -ELEMENTS[52506] = Fluid3D([18451,18472,18484,18544],0); -ELEMENTS[52507] = Fluid3D([18484,18451,18544,18441],0); -ELEMENTS[52508] = Fluid3D([18544,18484,18441,18506],0); -ELEMENTS[52509] = Fluid3D([18544,18484,18506,18591],0); -ELEMENTS[52510] = Fluid3D([18544,18484,18591,18472],0); -ELEMENTS[52511] = Fluid3D([18484,18506,18591,18434],0); -ELEMENTS[52512] = Fluid3D([18484,18441,18506,18223],0); -ELEMENTS[52513] = Fluid3D([18332,18484,18328,18223],0); -ELEMENTS[52514] = Fluid3D([18328,18332,18223,18132],0); -ELEMENTS[52515] = Fluid3D([18332,18451,18484,18441],0); -ELEMENTS[52516] = Fluid3D([18328,18332,18132,18235],0); -ELEMENTS[52517] = Fluid3D([18328,18332,18235,18472],0); -ELEMENTS[52518] = Fluid3D([18332,18132,18235,18252],0); -ELEMENTS[52519] = Fluid3D([18235,18332,18252,18472],0); -ELEMENTS[52520] = Fluid3D([10951,11123,10288,10525],0); -ELEMENTS[52521] = Fluid3D([10951,11123,10525,11613],0); -ELEMENTS[52522] = Fluid3D([11123,10288,10525,11134],0); -ELEMENTS[52523] = Fluid3D([10525,11123,11134,11613],0); -ELEMENTS[52524] = Fluid3D([17319,17419,16980,17258],0); -ELEMENTS[52525] = Fluid3D([16980,17319,17258,17180],0); -ELEMENTS[52526] = Fluid3D([17319,17258,17180,17565],0); -ELEMENTS[52527] = Fluid3D([5624,5729,5529,5072],0); -ELEMENTS[52528] = Fluid3D([5624,5729,5072,5162],0); -ELEMENTS[52529] = Fluid3D([9755,9410,10696,10178],0); -ELEMENTS[52530] = Fluid3D([11881,12733,13046,12647],0); -ELEMENTS[52531] = Fluid3D([14066,14153,14529,15030],0); -ELEMENTS[52532] = Fluid3D([9138,9596,10227,9861],0); -ELEMENTS[52533] = Fluid3D([15552,15290,15542,15170],0); -ELEMENTS[52534] = Fluid3D([15927,15587,16060,15716],0); -ELEMENTS[52535] = Fluid3D([15587,16060,15716,16137],0); -ELEMENTS[52536] = Fluid3D([5626,6116,5757,5464],0); -ELEMENTS[52537] = Fluid3D([5626,6116,5464,5479],0); -ELEMENTS[52538] = Fluid3D([6116,5464,5479,6013],0); -ELEMENTS[52539] = Fluid3D([5464,5626,5479,5093],0); -ELEMENTS[52540] = Fluid3D([5479,5464,5093,5017],0); -ELEMENTS[52541] = Fluid3D([5479,5464,5017,5047],0); -ELEMENTS[52542] = Fluid3D([5464,5093,5017,5626],0); -ELEMENTS[52543] = Fluid3D([5464,5017,5047,5583],0); -ELEMENTS[52544] = Fluid3D([5464,5017,5583,5757],0); -ELEMENTS[52545] = Fluid3D([6116,5464,6013,5757],0); -ELEMENTS[52546] = Fluid3D([5017,5464,5626,5757],0); -ELEMENTS[52547] = Fluid3D([5464,5479,6013,5674],0); -ELEMENTS[52548] = Fluid3D([5479,5464,5047,5674],0); -ELEMENTS[52549] = Fluid3D([11224,12033,11092,11867],0); -ELEMENTS[52550] = Fluid3D([10320,11237,10688,10021],0); -ELEMENTS[52551] = Fluid3D([11654,10671,11498,11932],0); -ELEMENTS[52552] = Fluid3D([11498,11654,11932,12494],0); -ELEMENTS[52553] = Fluid3D([11654,11932,12494,12840],0); -ELEMENTS[52554] = Fluid3D([11654,10671,11932,10851],0); -ELEMENTS[52555] = Fluid3D([9073,7868,8216,8176],0); -ELEMENTS[52556] = Fluid3D([18537,18534,18574,18626],0); -ELEMENTS[52557] = Fluid3D([6305,5959,6617,6038],0); -ELEMENTS[52558] = Fluid3D([2827,2514,2744,2872],0); -ELEMENTS[52559] = Fluid3D([3285,3173,2859,3187],0); -ELEMENTS[52560] = Fluid3D([16767,17022,17074,17271],0); -ELEMENTS[52561] = Fluid3D([16767,17022,17271,16805],0); -ELEMENTS[52562] = Fluid3D([10466,10551,10501,11174],0); -ELEMENTS[52563] = Fluid3D([11575,11196,11866,12624],0); -ELEMENTS[52564] = Fluid3D([3682,3965,4281,3827],0); -ELEMENTS[52565] = Fluid3D([3682,3965,3827,3684],0); -ELEMENTS[52566] = Fluid3D([4281,3682,3827,3837],0); -ELEMENTS[52567] = Fluid3D([3965,3827,3684,4001],0); -ELEMENTS[52568] = Fluid3D([3827,3684,4001,3903],0); -ELEMENTS[52569] = Fluid3D([3684,4001,3903,3936],0); -ELEMENTS[52570] = Fluid3D([4001,3903,3936,4297],0); -ELEMENTS[52571] = Fluid3D([3827,3684,3903,3513],0); -ELEMENTS[52572] = Fluid3D([3903,3684,3936,3513],0); -ELEMENTS[52573] = Fluid3D([3936,3903,3513,3691],0); -ELEMENTS[52574] = Fluid3D([3903,3513,3691,3827],0); -ELEMENTS[52575] = Fluid3D([4001,3827,3903,4297],0); -ELEMENTS[52576] = Fluid3D([4001,3827,4297,3965],0); -ELEMENTS[52577] = Fluid3D([3936,3903,3691,4294],0); -ELEMENTS[52578] = Fluid3D([3936,3903,4294,4297],0); -ELEMENTS[52579] = Fluid3D([3684,4001,3936,4122],0); -ELEMENTS[52580] = Fluid3D([3684,4001,4122,3886],0); -ELEMENTS[52581] = Fluid3D([4001,3936,4122,4297],0); -ELEMENTS[52582] = Fluid3D([4122,4001,4297,3886],0); -ELEMENTS[52583] = Fluid3D([3684,4001,3886,3965],0); -ELEMENTS[52584] = Fluid3D([3513,3936,3691,3773],0); -ELEMENTS[52585] = Fluid3D([3691,3513,3773,3371],0); -ELEMENTS[52586] = Fluid3D([3691,3513,3371,3363],0); -ELEMENTS[52587] = Fluid3D([3827,3684,3513,3682],0); -ELEMENTS[52588] = Fluid3D([3827,3903,4297,4281],0); -ELEMENTS[52589] = Fluid3D([3691,3903,3827,4281],0); -ELEMENTS[52590] = Fluid3D([3773,3691,3371,3837],0); -ELEMENTS[52591] = Fluid3D([3773,3691,3837,4294],0); -ELEMENTS[52592] = Fluid3D([3691,3371,3837,3363],0); -ELEMENTS[52593] = Fluid3D([3837,3691,3363,3536],0); -ELEMENTS[52594] = Fluid3D([3837,3691,3536,3682],0); -ELEMENTS[52595] = Fluid3D([3513,3691,3827,3682],0); -ELEMENTS[52596] = Fluid3D([4001,4297,3886,3965],0); -ELEMENTS[52597] = Fluid3D([3363,3837,3536,3386],0); -ELEMENTS[52598] = Fluid3D([3536,3363,3386,3130],0); -ELEMENTS[52599] = Fluid3D([3386,3536,3130,3286],0); -ELEMENTS[52600] = Fluid3D([3837,3536,3386,4025],0); -ELEMENTS[52601] = Fluid3D([3363,3386,3130,2806],0); -ELEMENTS[52602] = Fluid3D([3536,3363,3130,3513],0); -ELEMENTS[52603] = Fluid3D([4297,3827,4281,3965],0); -ELEMENTS[52604] = Fluid3D([3371,3837,3363,3608],0); -ELEMENTS[52605] = Fluid3D([3363,3371,3608,3219],0); -ELEMENTS[52606] = Fluid3D([3837,3363,3608,3433],0); -ELEMENTS[52607] = Fluid3D([3363,3608,3433,3219],0); -ELEMENTS[52608] = Fluid3D([3608,3433,3219,3570],0); -ELEMENTS[52609] = Fluid3D([3936,3691,3773,4294],0); -ELEMENTS[52610] = Fluid3D([3837,3536,4025,3682],0); -ELEMENTS[52611] = Fluid3D([13117,13364,12277,12478],0); -ELEMENTS[52612] = Fluid3D([6191,6173,6757,6316],0); -ELEMENTS[52613] = Fluid3D([6263,5725,5974,6460],0); -ELEMENTS[52614] = Fluid3D([10582,10079,10451,10628],0); -ELEMENTS[52615] = Fluid3D([14170,14974,14132,14630],0); -ELEMENTS[52616] = Fluid3D([5670,5194,5084,5320],0); -ELEMENTS[52617] = Fluid3D([3467,3485,3826,3560],0); -ELEMENTS[52618] = Fluid3D([7372,7917,6855,7647],0); -ELEMENTS[52619] = Fluid3D([8902,9028,9445,8370],0); -ELEMENTS[52620] = Fluid3D([12291,11568,12542,12219],0); -ELEMENTS[52621] = Fluid3D([6188,6146,6583,5637],0); -ELEMENTS[52622] = Fluid3D([2503,2219,2204,2463],0); -ELEMENTS[52623] = Fluid3D([6650,7566,6540,7213],0); -ELEMENTS[52624] = Fluid3D([14717,14581,13949,14275],0); -ELEMENTS[52625] = Fluid3D([9799,9338,9885,10264],0); -ELEMENTS[52626] = Fluid3D([9338,9885,10264,9664],0); -ELEMENTS[52627] = Fluid3D([8035,7880,8353,7189],0); -ELEMENTS[52628] = Fluid3D([17099,17068,17501,17309],0); -ELEMENTS[52629] = Fluid3D([17501,17099,17309,17528],0); -ELEMENTS[52630] = Fluid3D([15612,16150,16019,15530],0); -ELEMENTS[52631] = Fluid3D([18156,18093,18090,17789],0); -ELEMENTS[52632] = Fluid3D([7711,7747,8742,7280],0); -ELEMENTS[52633] = Fluid3D([3421,3187,3590,3829],0); -ELEMENTS[52634] = Fluid3D([12784,12960,12753,13644],0); -ELEMENTS[52635] = Fluid3D([15077,15595,15262,15663],0); -ELEMENTS[52636] = Fluid3D([15077,15595,15663,15476],0); -ELEMENTS[52637] = Fluid3D([15115,15434,14987,14423],0); -ELEMENTS[52638] = Fluid3D([18320,18151,18402,18291],0); -ELEMENTS[52639] = Fluid3D([16187,16727,16541,16159],0); -ELEMENTS[52640] = Fluid3D([16307,16158,15702,16051],0); -ELEMENTS[52641] = Fluid3D([6860,6667,7461,7376],0); -ELEMENTS[52642] = Fluid3D([3676,3333,3404,3794],0); -ELEMENTS[52643] = Fluid3D([14650,15149,15356,14929],0); -ELEMENTS[52644] = Fluid3D([5108,4901,4811,5682],0); -ELEMENTS[52645] = Fluid3D([7617,7336,6814,7259],0); -ELEMENTS[52646] = Fluid3D([7617,7336,7259,7981],0); -ELEMENTS[52647] = Fluid3D([7259,7617,7981,7199],0); -ELEMENTS[52648] = Fluid3D([16304,16531,16594,16877],0); -ELEMENTS[52649] = Fluid3D([16531,16594,16877,16682],0); -ELEMENTS[52650] = Fluid3D([16594,16877,16682,17015],0); -ELEMENTS[52651] = Fluid3D([16594,16877,17015,17005],0); -ELEMENTS[52652] = Fluid3D([16594,16877,17005,16828],0); -ELEMENTS[52653] = Fluid3D([16877,17015,17005,17279],0); -ELEMENTS[52654] = Fluid3D([16594,16304,16877,16529],0); -ELEMENTS[52655] = Fluid3D([16304,16531,16877,16775],0); -ELEMENTS[52656] = Fluid3D([11496,11479,12429,12258],0); -ELEMENTS[52657] = Fluid3D([13241,13567,13162,12838],0); -ELEMENTS[52658] = Fluid3D([10629,10970,10218,9903],0); -ELEMENTS[52659] = Fluid3D([10218,10629,9903,9456],0); -ELEMENTS[52660] = Fluid3D([4119,3820,4184,4375],0); -ELEMENTS[52661] = Fluid3D([9279,8425,8847,9082],0); -ELEMENTS[52662] = Fluid3D([4827,4914,4956,5537],0); -ELEMENTS[52663] = Fluid3D([6055,6225,5926,5452],0); -ELEMENTS[52664] = Fluid3D([17714,17495,17446,17710],0); -ELEMENTS[52665] = Fluid3D([13119,12888,12515,13435],0); -ELEMENTS[52666] = Fluid3D([10006,9683,9954,8886],0); -ELEMENTS[52667] = Fluid3D([15667,16157,15786,16348],0); -ELEMENTS[52668] = Fluid3D([9465,10135,10352,9722],0); -ELEMENTS[52669] = Fluid3D([14565,14761,14298,15007],0); -ELEMENTS[52670] = Fluid3D([7291,8342,7815,7413],0); -ELEMENTS[52671] = Fluid3D([8342,7815,7413,8396],0); -ELEMENTS[52672] = Fluid3D([17870,17571,17644,17630],0); -ELEMENTS[52673] = Fluid3D([13041,13512,13040,12783],0); -ELEMENTS[52674] = Fluid3D([3560,4008,3874,4359],0); -ELEMENTS[52675] = Fluid3D([13705,14214,14361,14806],0); -ELEMENTS[52676] = Fluid3D([12774,11976,12602,13106],0); -ELEMENTS[52677] = Fluid3D([17979,18213,17857,18172],0); -ELEMENTS[52678] = Fluid3D([17857,17979,18172,18103],0); -ELEMENTS[52679] = Fluid3D([12802,12686,13596,12678],0); -ELEMENTS[52680] = Fluid3D([3843,3269,3545,3486],0); -ELEMENTS[52681] = Fluid3D([13262,12948,12561,13601],0); -ELEMENTS[52682] = Fluid3D([17514,17323,17550,17756],0); -ELEMENTS[52683] = Fluid3D([17550,17514,17756,17888],0); -ELEMENTS[52684] = Fluid3D([10625,10055,11188,10771],0); -ELEMENTS[52685] = Fluid3D([11188,10625,10771,11489],0); -ELEMENTS[52686] = Fluid3D([17308,17321,17390,16885],0); -ELEMENTS[52687] = Fluid3D([2422,2404,2326,2592],0); -ELEMENTS[52688] = Fluid3D([7484,7209,6967,7822],0); -ELEMENTS[52689] = Fluid3D([7484,7209,7822,8322],0); -ELEMENTS[52690] = Fluid3D([7822,7484,8322,7943],0); -ELEMENTS[52691] = Fluid3D([7822,7484,7943,6967],0); -ELEMENTS[52692] = Fluid3D([8322,7822,7943,8619],0); -ELEMENTS[52693] = Fluid3D([7822,7943,8619,7755],0); -ELEMENTS[52694] = Fluid3D([7822,7943,7755,6967],0); -ELEMENTS[52695] = Fluid3D([8619,7822,7755,7955],0); -ELEMENTS[52696] = Fluid3D([8322,7822,8619,8354],0); -ELEMENTS[52697] = Fluid3D([8322,7822,8354,7209],0); -ELEMENTS[52698] = Fluid3D([7822,8619,8354,7955],0); -ELEMENTS[52699] = Fluid3D([7755,7822,6967,7128],0); -ELEMENTS[52700] = Fluid3D([7755,7822,7128,7955],0); -ELEMENTS[52701] = Fluid3D([8619,8322,8354,9096],0); -ELEMENTS[52702] = Fluid3D([8354,8619,9096,9240],0); -ELEMENTS[52703] = Fluid3D([8619,9096,9240,9215],0); -ELEMENTS[52704] = Fluid3D([8619,8322,9096,9215],0); -ELEMENTS[52705] = Fluid3D([8322,8354,9096,8497],0); -ELEMENTS[52706] = Fluid3D([8354,9096,8497,8996],0); -ELEMENTS[52707] = Fluid3D([8497,8354,8996,7955],0); -ELEMENTS[52708] = Fluid3D([9240,8619,9215,8432],0); -ELEMENTS[52709] = Fluid3D([8322,8354,8497,7612],0); -ELEMENTS[52710] = Fluid3D([8354,8497,7612,7955],0); -ELEMENTS[52711] = Fluid3D([8354,8619,9240,7955],0); -ELEMENTS[52712] = Fluid3D([8354,9096,8996,9240],0); -ELEMENTS[52713] = Fluid3D([9240,8619,8432,8595],0); -ELEMENTS[52714] = Fluid3D([9240,8619,8595,7955],0); -ELEMENTS[52715] = Fluid3D([7943,8619,7755,8432],0); -ELEMENTS[52716] = Fluid3D([8354,8996,7955,9240],0); -ELEMENTS[52717] = Fluid3D([7209,6967,7822,7128],0); -ELEMENTS[52718] = Fluid3D([7822,7209,7128,8354],0); -ELEMENTS[52719] = Fluid3D([7209,6967,7128,6369],0); -ELEMENTS[52720] = Fluid3D([7128,7209,6369,6534],0); -ELEMENTS[52721] = Fluid3D([3335,3364,3038,3480],0); -ELEMENTS[52722] = Fluid3D([5552,5664,6109,5342],0); -ELEMENTS[52723] = Fluid3D([15015,15306,14656,14437],0); -ELEMENTS[52724] = Fluid3D([11358,11653,10613,11205],0); -ELEMENTS[52725] = Fluid3D([10443,10313,9834,10153],0); -ELEMENTS[52726] = Fluid3D([10443,10313,10153,11084],0); -ELEMENTS[52727] = Fluid3D([10153,10443,11084,11305],0); -ELEMENTS[52728] = Fluid3D([9834,10443,10153,10771],0); -ELEMENTS[52729] = Fluid3D([10443,10153,10771,11305],0); -ELEMENTS[52730] = Fluid3D([15333,15284,15611,14985],0); -ELEMENTS[52731] = Fluid3D([15333,15284,14985,14216],0); -ELEMENTS[52732] = Fluid3D([15611,15333,14985,14770],0); -ELEMENTS[52733] = Fluid3D([3506,3291,3206,3060],0); -ELEMENTS[52734] = Fluid3D([7553,6980,7869,7863],0); -ELEMENTS[52735] = Fluid3D([7869,7553,7863,8425],0); -ELEMENTS[52736] = Fluid3D([7863,7869,8425,8847],0); -ELEMENTS[52737] = Fluid3D([9139,9187,9090,10304],0); -ELEMENTS[52738] = Fluid3D([9130,8216,8073,8165],0); -ELEMENTS[52739] = Fluid3D([7937,7300,7077,7616],0); -ELEMENTS[52740] = Fluid3D([4597,5091,4666,5100],0); -ELEMENTS[52741] = Fluid3D([3678,3603,3238,3637],0); -ELEMENTS[52742] = Fluid3D([17228,17578,17017,17338],0); -ELEMENTS[52743] = Fluid3D([12886,12258,12288,13136],0); -ELEMENTS[52744] = Fluid3D([8573,8905,9014,9902],0); -ELEMENTS[52745] = Fluid3D([4920,5068,4985,5433],0); -ELEMENTS[52746] = Fluid3D([12195,13059,12156,13004],0); -ELEMENTS[52747] = Fluid3D([13531,12757,13595,13481],0); -ELEMENTS[52748] = Fluid3D([13595,13531,13481,13980],0); -ELEMENTS[52749] = Fluid3D([13481,13595,13980,14064],0); -ELEMENTS[52750] = Fluid3D([13531,13481,13980,13090],0); -ELEMENTS[52751] = Fluid3D([13980,13481,14064,13055],0); -ELEMENTS[52752] = Fluid3D([12757,13595,13481,12901],0); -ELEMENTS[52753] = Fluid3D([13595,13481,12901,14064],0); -ELEMENTS[52754] = Fluid3D([13980,13481,13055,13090],0); -ELEMENTS[52755] = Fluid3D([12757,13595,12901,13191],0); -ELEMENTS[52756] = Fluid3D([12377,12212,12097,12996],0); -ELEMENTS[52757] = Fluid3D([12212,12097,12996,12367],0); -ELEMENTS[52758] = Fluid3D([12377,12212,12996,13274],0); -ELEMENTS[52759] = Fluid3D([12996,12212,12367,13246],0); -ELEMENTS[52760] = Fluid3D([12367,12996,13246,12784],0); -ELEMENTS[52761] = Fluid3D([17219,17407,17455,17606],0); -ELEMENTS[52762] = Fluid3D([12177,11365,11405,12207],0); -ELEMENTS[52763] = Fluid3D([14863,14831,14186,15134],0); -ELEMENTS[52764] = Fluid3D([11669,11170,11362,10889],0); -ELEMENTS[52765] = Fluid3D([7780,7058,7109,6939],0); -ELEMENTS[52766] = Fluid3D([12019,12305,13204,13176],0); -ELEMENTS[52767] = Fluid3D([8655,8569,9259,8270],0); -ELEMENTS[52768] = Fluid3D([8655,8569,8270,7478],0); -ELEMENTS[52769] = Fluid3D([9259,8655,8270,8764],0); -ELEMENTS[52770] = Fluid3D([4221,3883,4451,4314],0); -ELEMENTS[52771] = Fluid3D([5302,5283,4775,4986],0); -ELEMENTS[52772] = Fluid3D([5283,4775,4986,4857],0); -ELEMENTS[52773] = Fluid3D([4986,5283,4857,5200],0); -ELEMENTS[52774] = Fluid3D([4857,4986,5200,4583],0); -ELEMENTS[52775] = Fluid3D([4775,4986,4857,4241],0); -ELEMENTS[52776] = Fluid3D([4986,4857,4241,4583],0); -ELEMENTS[52777] = Fluid3D([3236,3363,3002,2806],0); -ELEMENTS[52778] = Fluid3D([17361,17129,17198,16916],0); -ELEMENTS[52779] = Fluid3D([17198,17361,16916,17240],0); -ELEMENTS[52780] = Fluid3D([15731,15979,16141,16453],0); -ELEMENTS[52781] = Fluid3D([10591,11682,11234,10796],0); -ELEMENTS[52782] = Fluid3D([11234,10591,10796,10351],0); -ELEMENTS[52783] = Fluid3D([10796,11234,10351,11196],0); -ELEMENTS[52784] = Fluid3D([11234,10351,11196,11866],0); -ELEMENTS[52785] = Fluid3D([11196,11234,11866,11947],0); -ELEMENTS[52786] = Fluid3D([11682,11234,10796,11947],0); -ELEMENTS[52787] = Fluid3D([8002,7488,7351,8406],0); -ELEMENTS[52788] = Fluid3D([8002,7488,8406,8007],0); -ELEMENTS[52789] = Fluid3D([8406,8002,8007,8832],0); -ELEMENTS[52790] = Fluid3D([8406,8002,8832,8699],0); -ELEMENTS[52791] = Fluid3D([8406,8002,8699,7351],0); -ELEMENTS[52792] = Fluid3D([14521,13900,14358,14883],0); -ELEMENTS[52793] = Fluid3D([6509,6953,7250,6302],0); -ELEMENTS[52794] = Fluid3D([11811,11417,12347,12316],0); -ELEMENTS[52795] = Fluid3D([7648,7971,8289,8650],0); -ELEMENTS[52796] = Fluid3D([7971,8289,8650,8747],0); -ELEMENTS[52797] = Fluid3D([7648,7971,8650,7431],0); -ELEMENTS[52798] = Fluid3D([3700,3681,4116,4296],0); -ELEMENTS[52799] = Fluid3D([17521,17332,17313,17272],0); -ELEMENTS[52800] = Fluid3D([7059,6771,7105,6214],0); -ELEMENTS[52801] = Fluid3D([3769,4011,4449,3990],0); -ELEMENTS[52802] = Fluid3D([4011,4449,3990,4105],0); -ELEMENTS[52803] = Fluid3D([4011,4449,4105,4318],0); -ELEMENTS[52804] = Fluid3D([3769,4011,3990,3553],0); -ELEMENTS[52805] = Fluid3D([4105,4011,4318,3662],0); -ELEMENTS[52806] = Fluid3D([5477,5323,5929,5058],0); -ELEMENTS[52807] = Fluid3D([5477,5323,5058,4718],0); -ELEMENTS[52808] = Fluid3D([10058,10534,11249,11069],0); -ELEMENTS[52809] = Fluid3D([12291,11883,12904,11968],0); -ELEMENTS[52810] = Fluid3D([13077,12955,13609,12476],0); -ELEMENTS[52811] = Fluid3D([3814,4258,4230,3894],0); -ELEMENTS[52812] = Fluid3D([12635,12846,13625,13554],0); -ELEMENTS[52813] = Fluid3D([7284,6888,6747,6946],0); -ELEMENTS[52814] = Fluid3D([14070,14193,14630,15147],0); -ELEMENTS[52815] = Fluid3D([5217,5340,5576,5205],0); -ELEMENTS[52816] = Fluid3D([4306,4308,3886,4092],0); -ELEMENTS[52817] = Fluid3D([18152,18163,18070,18259],0); -ELEMENTS[52818] = Fluid3D([18152,18163,18259,18338],0); -ELEMENTS[52819] = Fluid3D([18152,18163,18338,18188],0); -ELEMENTS[52820] = Fluid3D([18259,18152,18338,18410],0); -ELEMENTS[52821] = Fluid3D([18338,18152,18188,18326],0); -ELEMENTS[52822] = Fluid3D([18188,18338,18326,18376],0); -ELEMENTS[52823] = Fluid3D([18338,18326,18376,18410],0); -ELEMENTS[52824] = Fluid3D([18338,18326,18410,18152],0); -ELEMENTS[52825] = Fluid3D([18188,18338,18376,18403],0); -ELEMENTS[52826] = Fluid3D([18338,18376,18403,18509],0); -ELEMENTS[52827] = Fluid3D([18376,18403,18509,18359],0); -ELEMENTS[52828] = Fluid3D([18509,18376,18359,18440],0); -ELEMENTS[52829] = Fluid3D([18509,18376,18440,18410],0); -ELEMENTS[52830] = Fluid3D([18376,18359,18440,18326],0); -ELEMENTS[52831] = Fluid3D([18440,18376,18326,18410],0); -ELEMENTS[52832] = Fluid3D([18326,18440,18410,18314],0); -ELEMENTS[52833] = Fluid3D([18326,18440,18314,18359],0); -ELEMENTS[52834] = Fluid3D([18326,18188,18376,18359],0); -ELEMENTS[52835] = Fluid3D([18376,18188,18403,18359],0); -ELEMENTS[52836] = Fluid3D([18359,18509,18440,18580],0); -ELEMENTS[52837] = Fluid3D([18338,18376,18509,18410],0); -ELEMENTS[52838] = Fluid3D([18440,18314,18359,18415],0); -ELEMENTS[52839] = Fluid3D([18070,18152,18259,18096],0); -ELEMENTS[52840] = Fluid3D([18152,18259,18096,18410],0); -ELEMENTS[52841] = Fluid3D([12100,11498,11997,12918],0); -ELEMENTS[52842] = Fluid3D([6707,6186,6472,6407],0); -ELEMENTS[52843] = Fluid3D([10018,10814,11051,10948],0); -ELEMENTS[52844] = Fluid3D([10018,10814,10948,10484],0); -ELEMENTS[52845] = Fluid3D([10948,10018,10484,10382],0); -ELEMENTS[52846] = Fluid3D([10484,10948,10382,11198],0); -ELEMENTS[52847] = Fluid3D([10484,10948,11198,11470],0); -ELEMENTS[52848] = Fluid3D([10948,10382,11198,11316],0); -ELEMENTS[52849] = Fluid3D([10382,10484,11198,10236],0); -ELEMENTS[52850] = Fluid3D([11198,10382,10236,11495],0); -ELEMENTS[52851] = Fluid3D([10382,10484,10236,9540],0); -ELEMENTS[52852] = Fluid3D([10236,10382,9540,9314],0); -ELEMENTS[52853] = Fluid3D([11198,10382,11495,11316],0); -ELEMENTS[52854] = Fluid3D([10382,10484,9540,10018],0); -ELEMENTS[52855] = Fluid3D([9540,10382,10018,9966],0); -ELEMENTS[52856] = Fluid3D([10236,11198,11495,11191],0); -ELEMENTS[52857] = Fluid3D([11198,11495,11191,12138],0); -ELEMENTS[52858] = Fluid3D([10236,11198,11191,10484],0); -ELEMENTS[52859] = Fluid3D([10948,10018,10382,11051],0); -ELEMENTS[52860] = Fluid3D([10484,10948,11470,10750],0); -ELEMENTS[52861] = Fluid3D([10236,10382,9314,10430],0); -ELEMENTS[52862] = Fluid3D([10236,10382,10430,11495],0); -ELEMENTS[52863] = Fluid3D([10484,10948,10750,10814],0); -ELEMENTS[52864] = Fluid3D([10814,11051,10948,12074],0); -ELEMENTS[52865] = Fluid3D([9314,10236,10430,10038],0); -ELEMENTS[52866] = Fluid3D([10236,10430,10038,10988],0); -ELEMENTS[52867] = Fluid3D([10430,9314,10038,9133],0); -ELEMENTS[52868] = Fluid3D([10430,10038,10988,10572],0); -ELEMENTS[52869] = Fluid3D([10430,10038,10572,9133],0); -ELEMENTS[52870] = Fluid3D([10038,10988,10572,10822],0); -ELEMENTS[52871] = Fluid3D([11191,11198,12138,11470],0); -ELEMENTS[52872] = Fluid3D([3229,3184,2845,3191],0); -ELEMENTS[52873] = Fluid3D([13880,14178,13794,13234],0); -ELEMENTS[52874] = Fluid3D([13880,14178,13234,13883],0); -ELEMENTS[52875] = Fluid3D([10303,9413,9785,9306],0); -ELEMENTS[52876] = Fluid3D([13281,13530,13762,13229],0); -ELEMENTS[52877] = Fluid3D([13530,13762,13229,14381],0); -ELEMENTS[52878] = Fluid3D([10921,10429,9689,10826],0); -ELEMENTS[52879] = Fluid3D([15363,15499,14860,14952],0); -ELEMENTS[52880] = Fluid3D([7129,6513,7396,7242],0); -ELEMENTS[52881] = Fluid3D([7129,6513,7242,6365],0); -ELEMENTS[52882] = Fluid3D([7396,7129,7242,8140],0); -ELEMENTS[52883] = Fluid3D([18309,18026,17982,17802],0); -ELEMENTS[52884] = Fluid3D([3852,4156,3773,3837],0); -ELEMENTS[52885] = Fluid3D([15989,16263,15382,15457],0); -ELEMENTS[52886] = Fluid3D([13090,13467,13055,13980],0); -ELEMENTS[52887] = Fluid3D([8945,9392,8947,8291],0); -ELEMENTS[52888] = Fluid3D([12750,13530,13598,13444],0); -ELEMENTS[52889] = Fluid3D([12750,13530,13444,12918],0); -ELEMENTS[52890] = Fluid3D([13530,13444,12918,13773],0); -ELEMENTS[52891] = Fluid3D([4253,4460,4054,3815],0); -ELEMENTS[52892] = Fluid3D([9709,9320,8591,9788],0); -ELEMENTS[52893] = Fluid3D([14568,14574,14117,15167],0); -ELEMENTS[52894] = Fluid3D([14568,14574,15167,15121],0); -ELEMENTS[52895] = Fluid3D([15167,14568,15121,15485],0); -ELEMENTS[52896] = Fluid3D([4795,4883,5094,4679],0); -ELEMENTS[52897] = Fluid3D([2386,2249,2379,2062],0); -ELEMENTS[52898] = Fluid3D([15932,15685,16329,15369],0); -ELEMENTS[52899] = Fluid3D([15932,15685,15369,15518],0); -ELEMENTS[52900] = Fluid3D([13005,12824,12481,12047],0); -ELEMENTS[52901] = Fluid3D([17483,17850,17416,17790],0); -ELEMENTS[52902] = Fluid3D([8474,7881,7669,7468],0); -ELEMENTS[52903] = Fluid3D([8474,7881,7468,8266],0); -ELEMENTS[52904] = Fluid3D([7881,7669,7468,6680],0); -ELEMENTS[52905] = Fluid3D([1856,1919,1897,2075],0); -ELEMENTS[52906] = Fluid3D([6180,6386,6140,7244],0); -ELEMENTS[52907] = Fluid3D([8083,7362,7231,7544],0); -ELEMENTS[52908] = Fluid3D([4803,5201,4907,5429],0); -ELEMENTS[52909] = Fluid3D([12941,12190,13073,12541],0); -ELEMENTS[52910] = Fluid3D([17369,17234,17096,17551],0); -ELEMENTS[52911] = Fluid3D([8500,8540,9476,9504],0); -ELEMENTS[52912] = Fluid3D([8540,9476,9504,9487],0); -ELEMENTS[52913] = Fluid3D([2433,2528,2264,2207],0); -ELEMENTS[52914] = Fluid3D([2433,2528,2207,2368],0); -ELEMENTS[52915] = Fluid3D([14031,14305,14971,14976],0); -ELEMENTS[52916] = Fluid3D([16455,16071,16799,16762],0); -ELEMENTS[52917] = Fluid3D([9088,8351,9261,8645],0); -ELEMENTS[52918] = Fluid3D([4628,4377,4663,5081],0); -ELEMENTS[52919] = Fluid3D([2233,2075,2262,2319],0); -ELEMENTS[52920] = Fluid3D([2262,2233,2319,2598],0); -ELEMENTS[52921] = Fluid3D([2233,2075,2319,2267],0); -ELEMENTS[52922] = Fluid3D([2319,2233,2267,2496],0); -ELEMENTS[52923] = Fluid3D([2319,2233,2496,2598],0); -ELEMENTS[52924] = Fluid3D([2233,2267,2496,2493],0); -ELEMENTS[52925] = Fluid3D([2496,2233,2493,2598],0); -ELEMENTS[52926] = Fluid3D([2267,2319,2496,2340],0); -ELEMENTS[52927] = Fluid3D([2267,2319,2340,2075],0); -ELEMENTS[52928] = Fluid3D([2233,2075,2267,2182],0); -ELEMENTS[52929] = Fluid3D([2496,2267,2340,2450],0); -ELEMENTS[52930] = Fluid3D([2267,2340,2450,2379],0); -ELEMENTS[52931] = Fluid3D([2496,2267,2450,2493],0); -ELEMENTS[52932] = Fluid3D([2450,2496,2493,2742],0); -ELEMENTS[52933] = Fluid3D([2340,2267,2075,2064],0); -ELEMENTS[52934] = Fluid3D([2340,2267,2064,2114],0); -ELEMENTS[52935] = Fluid3D([2267,2340,2379,2114],0); -ELEMENTS[52936] = Fluid3D([2493,2496,2598,2770],0); -ELEMENTS[52937] = Fluid3D([2075,2267,2182,2064],0); -ELEMENTS[52938] = Fluid3D([2493,2496,2770,2742],0); -ELEMENTS[52939] = Fluid3D([2496,2770,2742,2555],0); -ELEMENTS[52940] = Fluid3D([2496,2770,2555,2598],0); -ELEMENTS[52941] = Fluid3D([2770,2742,2555,2905],0); -ELEMENTS[52942] = Fluid3D([2770,2742,2905,2718],0); -ELEMENTS[52943] = Fluid3D([15031,15519,15428,15141],0); -ELEMENTS[52944] = Fluid3D([15031,15519,15141,14915],0); -ELEMENTS[52945] = Fluid3D([15519,15428,15141,15686],0); -ELEMENTS[52946] = Fluid3D([12645,12327,13393,12719],0); -ELEMENTS[52947] = Fluid3D([2485,2389,2298,2652],0); -ELEMENTS[52948] = Fluid3D([10421,9646,9973,9069],0); -ELEMENTS[52949] = Fluid3D([9646,9973,9069,8811],0); -ELEMENTS[52950] = Fluid3D([17725,17776,17878,17531],0); -ELEMENTS[52951] = Fluid3D([6431,6941,6688,6668],0); -ELEMENTS[52952] = Fluid3D([6740,6143,6886,6656],0); -ELEMENTS[52953] = Fluid3D([3683,3492,3990,3484],0); -ELEMENTS[52954] = Fluid3D([3990,3683,3484,3553],0); -ELEMENTS[52955] = Fluid3D([3683,3492,3484,3284],0); -ELEMENTS[52956] = Fluid3D([3484,3683,3284,3553],0); -ELEMENTS[52957] = Fluid3D([3284,3484,3553,3246],0); -ELEMENTS[52958] = Fluid3D([3284,3484,3246,3117],0); -ELEMENTS[52959] = Fluid3D([3284,3484,3117,3492],0); -ELEMENTS[52960] = Fluid3D([3484,3246,3117,3299],0); -ELEMENTS[52961] = Fluid3D([2167,2283,2261,2034],0); -ELEMENTS[52962] = Fluid3D([13075,12393,13024,12819],0); -ELEMENTS[52963] = Fluid3D([13075,12393,12819,12260],0); -ELEMENTS[52964] = Fluid3D([12393,12819,12260,11979],0); -ELEMENTS[52965] = Fluid3D([12393,13024,12819,11979],0); -ELEMENTS[52966] = Fluid3D([12819,13075,12260,13575],0); -ELEMENTS[52967] = Fluid3D([12819,12260,11979,12813],0); -ELEMENTS[52968] = Fluid3D([12819,12260,12813,13034],0); -ELEMENTS[52969] = Fluid3D([12813,12819,13034,13872],0); -ELEMENTS[52970] = Fluid3D([12819,12260,13034,13575],0); -ELEMENTS[52971] = Fluid3D([11979,12819,12813,13024],0); -ELEMENTS[52972] = Fluid3D([12819,12813,13024,13872],0); -ELEMENTS[52973] = Fluid3D([13034,12819,13575,13872],0); -ELEMENTS[52974] = Fluid3D([12591,11863,11673,11958],0); -ELEMENTS[52975] = Fluid3D([5054,5194,5075,5679],0); -ELEMENTS[52976] = Fluid3D([9924,9175,10043,9330],0); -ELEMENTS[52977] = Fluid3D([10043,9924,9330,10612],0); -ELEMENTS[52978] = Fluid3D([4758,4584,4421,4166],0); -ELEMENTS[52979] = Fluid3D([10117,10831,11131,10807],0); -ELEMENTS[52980] = Fluid3D([10117,10831,10807,11447],0); -ELEMENTS[52981] = Fluid3D([10807,10117,11447,10109],0); -ELEMENTS[52982] = Fluid3D([10831,11131,10807,12016],0); -ELEMENTS[52983] = Fluid3D([4111,3854,4118,3547],0); -ELEMENTS[52984] = Fluid3D([17676,17677,17495,17254],0); -ELEMENTS[52985] = Fluid3D([4778,4259,4231,4724],0); -ELEMENTS[52986] = Fluid3D([4778,4259,4724,4425],0); -ELEMENTS[52987] = Fluid3D([15528,15572,15018,15315],0); -ELEMENTS[52988] = Fluid3D([15018,15528,15315,15692],0); -ELEMENTS[52989] = Fluid3D([14050,13394,14118,13986],0); -ELEMENTS[52990] = Fluid3D([8691,8839,7795,8157],0); -ELEMENTS[52991] = Fluid3D([2484,2210,2256,2326],0); -ELEMENTS[52992] = Fluid3D([2256,2484,2326,2638],0); -ELEMENTS[52993] = Fluid3D([12585,12222,12389,11782],0); -ELEMENTS[52994] = Fluid3D([15317,15704,14915,15519],0); -ELEMENTS[52995] = Fluid3D([15317,15704,15519,15686],0); -ELEMENTS[52996] = Fluid3D([16110,15531,15513,15947],0); -ELEMENTS[52997] = Fluid3D([5671,5207,5902,5319],0); -ELEMENTS[52998] = Fluid3D([10270,10179,10983,11066],0); -ELEMENTS[52999] = Fluid3D([10270,10179,11066,10737],0); -ELEMENTS[53000] = Fluid3D([11066,10270,10737,11390],0); -ELEMENTS[53001] = Fluid3D([10179,10983,11066,10920],0); -ELEMENTS[53002] = Fluid3D([11066,10179,10920,10737],0); -ELEMENTS[53003] = Fluid3D([9906,9276,9355,10524],0); -ELEMENTS[53004] = Fluid3D([5406,5641,5197,4958],0); -ELEMENTS[53005] = Fluid3D([12278,12713,12295,13060],0); -ELEMENTS[53006] = Fluid3D([12552,13341,12304,12373],0); -ELEMENTS[53007] = Fluid3D([2012,2034,1854,1876],0); -ELEMENTS[53008] = Fluid3D([13000,12332,12989,13084],0); -ELEMENTS[53009] = Fluid3D([12332,12989,13084,12381],0); -ELEMENTS[53010] = Fluid3D([13000,12332,13084,12539],0); -ELEMENTS[53011] = Fluid3D([12332,13084,12539,12082],0); -ELEMENTS[53012] = Fluid3D([12539,12332,12082,12450],0); -ELEMENTS[53013] = Fluid3D([12082,12539,12450,12894],0); -ELEMENTS[53014] = Fluid3D([12539,12450,12894,13331],0); -ELEMENTS[53015] = Fluid3D([12539,12450,13331,13000],0); -ELEMENTS[53016] = Fluid3D([12539,12450,13000,12332],0); -ELEMENTS[53017] = Fluid3D([12082,12539,12894,13084],0); -ELEMENTS[53018] = Fluid3D([12539,12894,13084,13379],0); -ELEMENTS[53019] = Fluid3D([12539,12894,13379,13331],0); -ELEMENTS[53020] = Fluid3D([13379,12539,13331,13000],0); -ELEMENTS[53021] = Fluid3D([13331,13379,13000,13817],0); -ELEMENTS[53022] = Fluid3D([13331,13379,13817,14079],0); -ELEMENTS[53023] = Fluid3D([13379,13817,14079,12894],0); -ELEMENTS[53024] = Fluid3D([13331,13379,14079,12894],0); -ELEMENTS[53025] = Fluid3D([13379,13000,13817,13084],0); -ELEMENTS[53026] = Fluid3D([13817,13379,13084,12894],0); -ELEMENTS[53027] = Fluid3D([13379,12539,13000,13084],0); -ELEMENTS[53028] = Fluid3D([13000,13817,13084,13587],0); -ELEMENTS[53029] = Fluid3D([9445,8767,9802,8651],0); -ELEMENTS[53030] = Fluid3D([9445,8767,8651,8370],0); -ELEMENTS[53031] = Fluid3D([14077,14156,14368,14144],0); -ELEMENTS[53032] = Fluid3D([14368,14077,14144,13333],0); -ELEMENTS[53033] = Fluid3D([14077,14156,14144,13652],0); -ELEMENTS[53034] = Fluid3D([2294,2337,2546,2438],0); -ELEMENTS[53035] = Fluid3D([9180,9888,9097,9371],0); -ELEMENTS[53036] = Fluid3D([9888,9097,9371,9702],0); -ELEMENTS[53037] = Fluid3D([9180,9888,9371,10027],0); -ELEMENTS[53038] = Fluid3D([9888,9371,10027,10329],0); -ELEMENTS[53039] = Fluid3D([9888,9371,10329,10767],0); -ELEMENTS[53040] = Fluid3D([10329,9888,10767,10775],0); -ELEMENTS[53041] = Fluid3D([10767,10329,10775,10310],0); -ELEMENTS[53042] = Fluid3D([10329,10775,10310,10027],0); -ELEMENTS[53043] = Fluid3D([10767,10329,10310,9371],0); -ELEMENTS[53044] = Fluid3D([10329,10775,10027,9888],0); -ELEMENTS[53045] = Fluid3D([10329,10310,9371,10027],0); -ELEMENTS[53046] = Fluid3D([10775,10767,10310,11594],0); -ELEMENTS[53047] = Fluid3D([10775,10767,11594,11300],0); -ELEMENTS[53048] = Fluid3D([14844,15074,14360,14217],0); -ELEMENTS[53049] = Fluid3D([14360,14844,14217,13972],0); -ELEMENTS[53050] = Fluid3D([14217,14360,13972,13408],0); -ELEMENTS[53051] = Fluid3D([14360,14844,13972,14637],0); -ELEMENTS[53052] = Fluid3D([10438,11270,11472,10505],0); -ELEMENTS[53053] = Fluid3D([10438,11270,10505,10315],0); -ELEMENTS[53054] = Fluid3D([10505,10438,10315,9563],0); -ELEMENTS[53055] = Fluid3D([10438,11270,10315,9883],0); -ELEMENTS[53056] = Fluid3D([10315,10438,9883,9563],0); -ELEMENTS[53057] = Fluid3D([11472,10438,10505,9786],0); -ELEMENTS[53058] = Fluid3D([10438,10505,9786,9563],0); -ELEMENTS[53059] = Fluid3D([10505,9786,9563,9757],0); -ELEMENTS[53060] = Fluid3D([10505,9786,9757,10721],0); -ELEMENTS[53061] = Fluid3D([9786,9563,9757,8675],0); -ELEMENTS[53062] = Fluid3D([9786,9757,10721,9411],0); -ELEMENTS[53063] = Fluid3D([10505,9786,10721,11472],0); -ELEMENTS[53064] = Fluid3D([9883,10315,9563,9380],0); -ELEMENTS[53065] = Fluid3D([9883,10315,9380,10139],0); -ELEMENTS[53066] = Fluid3D([9883,10315,10139,11092],0); -ELEMENTS[53067] = Fluid3D([9883,10315,11092,11270],0); -ELEMENTS[53068] = Fluid3D([15773,15365,15356,15583],0); -ELEMENTS[53069] = Fluid3D([15773,15365,15583,15995],0); -ELEMENTS[53070] = Fluid3D([15773,15365,15995,16165],0); -ELEMENTS[53071] = Fluid3D([15365,15583,15995,15191],0); -ELEMENTS[53072] = Fluid3D([18583,18544,18585,18623],0); -ELEMENTS[53073] = Fluid3D([18585,18583,18623,18608],0); -ELEMENTS[53074] = Fluid3D([18583,18623,18608,18662],0); -ELEMENTS[53075] = Fluid3D([18583,18544,18623,18591],0); -ELEMENTS[53076] = Fluid3D([18583,18623,18662,18644],0); -ELEMENTS[53077] = Fluid3D([2687,2892,2635,3148],0); -ELEMENTS[53078] = Fluid3D([11622,11132,11699,10920],0); -ELEMENTS[53079] = Fluid3D([6806,6181,7119,6332],0); -ELEMENTS[53080] = Fluid3D([9236,9117,9120,7908],0); -ELEMENTS[53081] = Fluid3D([15248,15143,15580,15791],0); -ELEMENTS[53082] = Fluid3D([15248,15143,15791,15386],0); -ELEMENTS[53083] = Fluid3D([15143,15791,15386,15120],0); -ELEMENTS[53084] = Fluid3D([15248,15143,15386,14691],0); -ELEMENTS[53085] = Fluid3D([15357,15596,16025,16317],0); -ELEMENTS[53086] = Fluid3D([15548,15326,15037,15772],0); -ELEMENTS[53087] = Fluid3D([17080,17113,16889,17532],0); -ELEMENTS[53088] = Fluid3D([17080,17113,17532,17239],0); -ELEMENTS[53089] = Fluid3D([17080,17113,17239,16839],0); -ELEMENTS[53090] = Fluid3D([17239,17080,16839,17045],0); -ELEMENTS[53091] = Fluid3D([4258,4230,4799,4738],0); -ELEMENTS[53092] = Fluid3D([4630,4311,4408,4007],0); -ELEMENTS[53093] = Fluid3D([8889,8531,8009,9504],0); -ELEMENTS[53094] = Fluid3D([8867,9042,8729,8015],0); -ELEMENTS[53095] = Fluid3D([16710,16887,17034,17209],0); -ELEMENTS[53096] = Fluid3D([16710,16887,17209,17062],0); -ELEMENTS[53097] = Fluid3D([16710,16887,17062,16730],0); -ELEMENTS[53098] = Fluid3D([13640,13241,12590,13574],0); -ELEMENTS[53099] = Fluid3D([11630,12263,11457,11541],0); -ELEMENTS[53100] = Fluid3D([7509,7318,8009,7605],0); -ELEMENTS[53101] = Fluid3D([2034,2012,2126,1876],0); -ELEMENTS[53102] = Fluid3D([5276,5559,4753,5089],0); -ELEMENTS[53103] = Fluid3D([14403,14873,14837,14722],0); -ELEMENTS[53104] = Fluid3D([16429,16602,16260,15992],0); -ELEMENTS[53105] = Fluid3D([7784,7354,6901,7524],0); -ELEMENTS[53106] = Fluid3D([17967,18215,18139,18048],0); -ELEMENTS[53107] = Fluid3D([3609,3631,4089,3548],0); -ELEMENTS[53108] = Fluid3D([3609,3631,3548,3175],0); -ELEMENTS[53109] = Fluid3D([3631,4089,3548,4205],0); -ELEMENTS[53110] = Fluid3D([4643,4779,5323,4718],0); -ELEMENTS[53111] = Fluid3D([14524,13634,14312,13750],0); -ELEMENTS[53112] = Fluid3D([13459,13127,13362,13866],0); -ELEMENTS[53113] = Fluid3D([16200,16378,15921,16341],0); -ELEMENTS[53114] = Fluid3D([6616,5997,5956,6109],0); -ELEMENTS[53115] = Fluid3D([3956,3721,3598,3506],0); -ELEMENTS[53116] = Fluid3D([3598,3956,3506,3641],0); -ELEMENTS[53117] = Fluid3D([3506,3598,3641,3138],0); -ELEMENTS[53118] = Fluid3D([3598,3956,3641,3977],0); -ELEMENTS[53119] = Fluid3D([3641,3598,3977,3880],0); -ELEMENTS[53120] = Fluid3D([3977,3641,3880,3712],0); -ELEMENTS[53121] = Fluid3D([3598,3956,3977,3777],0); -ELEMENTS[53122] = Fluid3D([3598,3977,3880,3777],0); -ELEMENTS[53123] = Fluid3D([3598,3956,3777,4030],0); -ELEMENTS[53124] = Fluid3D([3880,3977,3712,4259],0); -ELEMENTS[53125] = Fluid3D([3880,3977,4259,4171],0); -ELEMENTS[53126] = Fluid3D([3880,3977,4171,3777],0); -ELEMENTS[53127] = Fluid3D([3956,3641,3977,3868],0); -ELEMENTS[53128] = Fluid3D([1985,1823,1862,1969],0); -ELEMENTS[53129] = Fluid3D([1985,1823,1969,1917],0); -ELEMENTS[53130] = Fluid3D([12372,11415,12448,11614],0); -ELEMENTS[53131] = Fluid3D([11691,11925,12529,11618],0); -ELEMENTS[53132] = Fluid3D([5018,4619,4723,4475],0); -ELEMENTS[53133] = Fluid3D([13752,12997,14021,13516],0); -ELEMENTS[53134] = Fluid3D([5250,5738,5358,5385],0); -ELEMENTS[53135] = Fluid3D([5250,5738,5385,5053],0); -ELEMENTS[53136] = Fluid3D([5385,5250,5053,4637],0); -ELEMENTS[53137] = Fluid3D([12298,12767,13433,12763],0); -ELEMENTS[53138] = Fluid3D([2895,2655,2784,2674],0); -ELEMENTS[53139] = Fluid3D([2895,2655,2674,2548],0); -ELEMENTS[53140] = Fluid3D([17576,17817,17976,18033],0); -ELEMENTS[53141] = Fluid3D([12748,12974,12420,13330],0); -ELEMENTS[53142] = Fluid3D([18147,18138,18316,18286],0); -ELEMENTS[53143] = Fluid3D([18138,18316,18286,18424],0); -ELEMENTS[53144] = Fluid3D([5006,5112,4820,5448],0); -ELEMENTS[53145] = Fluid3D([14795,15198,14833,14374],0); -ELEMENTS[53146] = Fluid3D([13670,14262,13123,14164],0); -ELEMENTS[53147] = Fluid3D([13670,14262,14164,14649],0); -ELEMENTS[53148] = Fluid3D([11885,12220,11070,11578],0); -ELEMENTS[53149] = Fluid3D([11070,11885,11578,10699],0); -ELEMENTS[53150] = Fluid3D([11885,12220,11578,12154],0); -ELEMENTS[53151] = Fluid3D([11578,11885,12154,11601],0); -ELEMENTS[53152] = Fluid3D([12154,11578,11601,11687],0); -ELEMENTS[53153] = Fluid3D([12154,11578,11687,12220],0); -ELEMENTS[53154] = Fluid3D([11885,12154,11601,12750],0); -ELEMENTS[53155] = Fluid3D([11578,11687,12220,10977],0); -ELEMENTS[53156] = Fluid3D([11601,12154,11687,11424],0); -ELEMENTS[53157] = Fluid3D([7303,7417,6928,7990],0); -ELEMENTS[53158] = Fluid3D([7303,7417,7990,8208],0); -ELEMENTS[53159] = Fluid3D([7990,7303,8208,7937],0); -ELEMENTS[53160] = Fluid3D([8208,7990,7937,8505],0); -ELEMENTS[53161] = Fluid3D([7937,8208,8505,8429],0); -ELEMENTS[53162] = Fluid3D([7937,8208,8429,7616],0); -ELEMENTS[53163] = Fluid3D([7990,7303,7937,8505],0); -ELEMENTS[53164] = Fluid3D([7303,8208,7937,7077],0); -ELEMENTS[53165] = Fluid3D([8505,7937,8429,8323],0); -ELEMENTS[53166] = Fluid3D([7417,7990,8208,8268],0); -ELEMENTS[53167] = Fluid3D([9378,8402,8498,8909],0); -ELEMENTS[53168] = Fluid3D([17924,18055,17848,18160],0); -ELEMENTS[53169] = Fluid3D([17924,18055,18160,18039],0); -ELEMENTS[53170] = Fluid3D([13893,13443,13889,14173],0); -ELEMENTS[53171] = Fluid3D([13443,13889,14173,13377],0); -ELEMENTS[53172] = Fluid3D([9491,8773,8556,9387],0); -ELEMENTS[53173] = Fluid3D([7664,6937,7133,7273],0); -ELEMENTS[53174] = Fluid3D([2792,3056,2930,2504],0); -ELEMENTS[53175] = Fluid3D([13147,12685,12605,13694],0); -ELEMENTS[53176] = Fluid3D([12387,13008,13304,13265],0); -ELEMENTS[53177] = Fluid3D([12387,13008,13265,11748],0); -ELEMENTS[53178] = Fluid3D([13008,13304,13265,13623],0); -ELEMENTS[53179] = Fluid3D([16162,15586,15914,15767],0); -ELEMENTS[53180] = Fluid3D([17647,17527,17846,17621],0); -ELEMENTS[53181] = Fluid3D([17527,17846,17621,17628],0); -ELEMENTS[53182] = Fluid3D([12057,12102,11423,11447],0); -ELEMENTS[53183] = Fluid3D([6193,5908,5852,5417],0); -ELEMENTS[53184] = Fluid3D([5852,6193,5417,5489],0); -ELEMENTS[53185] = Fluid3D([18493,18574,18555,18616],0); -ELEMENTS[53186] = Fluid3D([14481,13739,13842,13815],0); -ELEMENTS[53187] = Fluid3D([14481,13739,13815,13883],0); -ELEMENTS[53188] = Fluid3D([13739,13842,13815,13136],0); -ELEMENTS[53189] = Fluid3D([13739,13842,13136,12754],0); -ELEMENTS[53190] = Fluid3D([13815,13739,13136,13234],0); -ELEMENTS[53191] = Fluid3D([4328,4792,4170,4584],0); -ELEMENTS[53192] = Fluid3D([3516,3770,3906,3895],0); -ELEMENTS[53193] = Fluid3D([3906,3516,3895,3428],0); -ELEMENTS[53194] = Fluid3D([3516,3895,3428,3498],0); -ELEMENTS[53195] = Fluid3D([3428,3516,3498,3068],0); -ELEMENTS[53196] = Fluid3D([3906,3516,3428,3502],0); -ELEMENTS[53197] = Fluid3D([3516,3428,3502,3146],0); -ELEMENTS[53198] = Fluid3D([3516,3428,3146,3068],0); -ELEMENTS[53199] = Fluid3D([3502,3516,3146,3065],0); -ELEMENTS[53200] = Fluid3D([3906,3516,3502,3669],0); -ELEMENTS[53201] = Fluid3D([3428,3502,3146,3011],0); -ELEMENTS[53202] = Fluid3D([3146,3428,3011,3068],0); -ELEMENTS[53203] = Fluid3D([3146,3502,3065,3011],0); -ELEMENTS[53204] = Fluid3D([3065,3146,3011,2891],0); -ELEMENTS[53205] = Fluid3D([3065,3146,2891,3102],0); -ELEMENTS[53206] = Fluid3D([3146,2891,3102,3068],0); -ELEMENTS[53207] = Fluid3D([3065,3146,3102,3516],0); -ELEMENTS[53208] = Fluid3D([2891,3102,3068,2811],0); -ELEMENTS[53209] = Fluid3D([3102,3146,3068,3516],0); -ELEMENTS[53210] = Fluid3D([2891,3102,2811,3065],0); -ELEMENTS[53211] = Fluid3D([3146,2891,3068,3011],0); -ELEMENTS[53212] = Fluid3D([2891,3068,3011,2709],0); -ELEMENTS[53213] = Fluid3D([2891,3068,2709,2767],0); -ELEMENTS[53214] = Fluid3D([3011,2891,2709,2660],0); -ELEMENTS[53215] = Fluid3D([2709,2891,2767,2811],0); -ELEMENTS[53216] = Fluid3D([2709,2891,2811,2734],0); -ELEMENTS[53217] = Fluid3D([2891,2811,2734,3065],0); -ELEMENTS[53218] = Fluid3D([2734,2891,3065,2753],0); -ELEMENTS[53219] = Fluid3D([3065,2734,2753,2676],0); -ELEMENTS[53220] = Fluid3D([2734,2753,2676,2439],0); -ELEMENTS[53221] = Fluid3D([2753,2676,2439,2660],0); -ELEMENTS[53222] = Fluid3D([2734,2891,2753,2623],0); -ELEMENTS[53223] = Fluid3D([2753,2734,2623,2439],0); -ELEMENTS[53224] = Fluid3D([2623,2753,2439,2660],0); -ELEMENTS[53225] = Fluid3D([2891,2753,2623,2709],0); -ELEMENTS[53226] = Fluid3D([2734,2623,2439,2421],0); -ELEMENTS[53227] = Fluid3D([2623,2439,2421,2709],0); -ELEMENTS[53228] = Fluid3D([2421,2623,2709,2734],0); -ELEMENTS[53229] = Fluid3D([2623,2753,2660,2709],0); -ELEMENTS[53230] = Fluid3D([2623,2891,2709,2734],0); -ELEMENTS[53231] = Fluid3D([2439,2623,2660,2709],0); -ELEMENTS[53232] = Fluid3D([2891,2753,2709,2660],0); -ELEMENTS[53233] = Fluid3D([2891,3065,2753,3011],0); -ELEMENTS[53234] = Fluid3D([2753,3065,2676,2931],0); -ELEMENTS[53235] = Fluid3D([2676,2753,2931,2660],0); -ELEMENTS[53236] = Fluid3D([3068,2891,2811,2767],0); -ELEMENTS[53237] = Fluid3D([3516,3895,3498,3504],0); -ELEMENTS[53238] = Fluid3D([3498,3516,3504,3068],0); -ELEMENTS[53239] = Fluid3D([3504,3498,3068,3139],0); -ELEMENTS[53240] = Fluid3D([3504,3498,3139,3595],0); -ELEMENTS[53241] = Fluid3D([3504,3498,3595,3979],0); -ELEMENTS[53242] = Fluid3D([3504,3498,3979,3895],0); -ELEMENTS[53243] = Fluid3D([3068,3102,3516,3504],0); -ELEMENTS[53244] = Fluid3D([6148,6515,6461,5711],0); -ELEMENTS[53245] = Fluid3D([9834,8852,9093,9633],0); -ELEMENTS[53246] = Fluid3D([8452,7584,8231,7721],0); -ELEMENTS[53247] = Fluid3D([14140,14727,14139,15181],0); -ELEMENTS[53248] = Fluid3D([14140,14727,15181,15055],0); -ELEMENTS[53249] = Fluid3D([14727,15181,15055,15037],0); -ELEMENTS[53250] = Fluid3D([14727,14139,15181,14921],0); -ELEMENTS[53251] = Fluid3D([15181,14727,14921,15793],0); -ELEMENTS[53252] = Fluid3D([14727,14139,14921,14357],0); -ELEMENTS[53253] = Fluid3D([14139,14921,14357,14273],0); -ELEMENTS[53254] = Fluid3D([14921,14727,14357,15355],0); -ELEMENTS[53255] = Fluid3D([16739,17120,16465,16768],0); -ELEMENTS[53256] = Fluid3D([16465,16739,16768,16240],0); -ELEMENTS[53257] = Fluid3D([16465,16739,16240,16619],0); -ELEMENTS[53258] = Fluid3D([16768,16465,16240,16252],0); -ELEMENTS[53259] = Fluid3D([16465,16240,16252,15622],0); -ELEMENTS[53260] = Fluid3D([16739,17120,16768,16950],0); -ELEMENTS[53261] = Fluid3D([16768,16739,16950,16240],0); -ELEMENTS[53262] = Fluid3D([16768,16465,16252,16776],0); -ELEMENTS[53263] = Fluid3D([16465,16252,16776,16468],0); -ELEMENTS[53264] = Fluid3D([16768,16465,16776,17120],0); -ELEMENTS[53265] = Fluid3D([16465,16739,16619,16437],0); -ELEMENTS[53266] = Fluid3D([16465,16739,16437,17051],0); -ELEMENTS[53267] = Fluid3D([16252,16776,16468,16474],0); -ELEMENTS[53268] = Fluid3D([16252,16776,16474,16674],0); -ELEMENTS[53269] = Fluid3D([16776,16468,16474,16913],0); -ELEMENTS[53270] = Fluid3D([5234,4987,5573,5611],0); -ELEMENTS[53271] = Fluid3D([17002,17254,17352,17393],0); -ELEMENTS[53272] = Fluid3D([17002,17254,17393,16976],0); -ELEMENTS[53273] = Fluid3D([8638,9674,9281,8934],0); -ELEMENTS[53274] = Fluid3D([9674,9281,8934,9851],0); -ELEMENTS[53275] = Fluid3D([9281,8638,8934,8046],0); -ELEMENTS[53276] = Fluid3D([11304,11713,10402,11542],0); -ELEMENTS[53277] = Fluid3D([8759,9553,9609,9811],0); -ELEMENTS[53278] = Fluid3D([4776,5021,4872,4266],0); -ELEMENTS[53279] = Fluid3D([2151,2052,2327,2318],0); -ELEMENTS[53280] = Fluid3D([7706,6828,7094,6697],0); -ELEMENTS[53281] = Fluid3D([8711,9239,9776,9368],0); -ELEMENTS[53282] = Fluid3D([5045,5234,5573,5747],0); -ELEMENTS[53283] = Fluid3D([5573,5045,5747,5790],0); -ELEMENTS[53284] = Fluid3D([5747,5573,5790,6221],0); -ELEMENTS[53285] = Fluid3D([5747,5573,6221,6083],0); -ELEMENTS[53286] = Fluid3D([5747,5573,6083,5234],0); -ELEMENTS[53287] = Fluid3D([6221,5747,6083,6676],0); -ELEMENTS[53288] = Fluid3D([5573,6221,6083,6137],0); -ELEMENTS[53289] = Fluid3D([6221,6083,6137,6789],0); -ELEMENTS[53290] = Fluid3D([6137,6221,6789,6822],0); -ELEMENTS[53291] = Fluid3D([6083,6137,6789,6224],0); -ELEMENTS[53292] = Fluid3D([6083,5573,6137,5611],0); -ELEMENTS[53293] = Fluid3D([5573,6221,6137,6004],0); -ELEMENTS[53294] = Fluid3D([5790,5747,6221,6571],0); -ELEMENTS[53295] = Fluid3D([5747,6221,6571,6676],0); -ELEMENTS[53296] = Fluid3D([6083,6221,6676,6789],0); -ELEMENTS[53297] = Fluid3D([5747,6083,6676,6233],0); -ELEMENTS[53298] = Fluid3D([6221,5790,6571,6822],0); -ELEMENTS[53299] = Fluid3D([6571,6221,6822,6789],0); -ELEMENTS[53300] = Fluid3D([6221,6571,6676,6789],0); -ELEMENTS[53301] = Fluid3D([10856,10238,11206,11254],0); -ELEMENTS[53302] = Fluid3D([16752,16903,16640,16383],0); -ELEMENTS[53303] = Fluid3D([10538,10376,11421,10504],0); -ELEMENTS[53304] = Fluid3D([15143,15120,15778,15791],0); -ELEMENTS[53305] = Fluid3D([15778,15143,15791,15580],0); -ELEMENTS[53306] = Fluid3D([15791,15778,15580,16173],0); -ELEMENTS[53307] = Fluid3D([15791,15778,16173,16434],0); -ELEMENTS[53308] = Fluid3D([15778,15580,16173,16384],0); -ELEMENTS[53309] = Fluid3D([16173,15778,16384,16434],0); -ELEMENTS[53310] = Fluid3D([16384,16173,16434,16738],0); -ELEMENTS[53311] = Fluid3D([15778,15143,15580,14942],0); -ELEMENTS[53312] = Fluid3D([1812,1752,1660,1828],0); -ELEMENTS[53313] = Fluid3D([6513,5907,6572,6655],0); -ELEMENTS[53314] = Fluid3D([6572,6513,6655,7396],0); -ELEMENTS[53315] = Fluid3D([4037,4278,3934,4241],0); -ELEMENTS[53316] = Fluid3D([17306,17322,17123,16717],0); -ELEMENTS[53317] = Fluid3D([13822,14033,13263,14209],0); -ELEMENTS[53318] = Fluid3D([13822,14033,14209,14742],0); -ELEMENTS[53319] = Fluid3D([14209,13822,14742,14030],0); -ELEMENTS[53320] = Fluid3D([14742,14209,14030,14779],0); -ELEMENTS[53321] = Fluid3D([8799,9110,9374,8306],0); -ELEMENTS[53322] = Fluid3D([13075,13402,12444,12555],0); -ELEMENTS[53323] = Fluid3D([16795,16308,16721,16406],0); -ELEMENTS[53324] = Fluid3D([15962,16130,16045,15707],0); -ELEMENTS[53325] = Fluid3D([1887,1874,2047,1812],0); -ELEMENTS[53326] = Fluid3D([9619,8865,10066,9824],0); -ELEMENTS[53327] = Fluid3D([9352,8863,9659,10061],0); -ELEMENTS[53328] = Fluid3D([16116,16421,16773,16276],0); -ELEMENTS[53329] = Fluid3D([16116,16421,16276,15636],0); -ELEMENTS[53330] = Fluid3D([16276,16116,15636,15784],0); -ELEMENTS[53331] = Fluid3D([16276,16116,15784,16390],0); -ELEMENTS[53332] = Fluid3D([7778,7093,7662,7107],0); -ELEMENTS[53333] = Fluid3D([16250,16487,16791,16631],0); -ELEMENTS[53334] = Fluid3D([16487,16791,16631,17104],0); -ELEMENTS[53335] = Fluid3D([8657,9684,9393,9509],0); -ELEMENTS[53336] = Fluid3D([9845,9204,8781,9755],0); -ELEMENTS[53337] = Fluid3D([5513,5942,5909,5272],0); -ELEMENTS[53338] = Fluid3D([12708,12108,12453,11259],0); -ELEMENTS[53339] = Fluid3D([4060,4165,4284,4804],0); -ELEMENTS[53340] = Fluid3D([4573,4851,5193,5123],0); -ELEMENTS[53341] = Fluid3D([4154,4348,3899,3995],0); -ELEMENTS[53342] = Fluid3D([10633,11515,11152,10893],0); -ELEMENTS[53343] = Fluid3D([17346,17577,17295,17386],0); -ELEMENTS[53344] = Fluid3D([17346,17577,17386,17669],0); -ELEMENTS[53345] = Fluid3D([4306,4445,4957,4922],0); -ELEMENTS[53346] = Fluid3D([17643,17855,17947,17896],0); -ELEMENTS[53347] = Fluid3D([11580,11381,11726,10722],0); -ELEMENTS[53348] = Fluid3D([11726,11580,10722,10742],0); -ELEMENTS[53349] = Fluid3D([11580,10722,10742,11381],0); -ELEMENTS[53350] = Fluid3D([11726,11580,10742,12082],0); -ELEMENTS[53351] = Fluid3D([11580,10742,12082,12252],0); -ELEMENTS[53352] = Fluid3D([10742,11580,11381,10582],0); -ELEMENTS[53353] = Fluid3D([10742,11580,10582,12252],0); -ELEMENTS[53354] = Fluid3D([16802,17225,16779,17073],0); -ELEMENTS[53355] = Fluid3D([14128,14009,14506,13812],0); -ELEMENTS[53356] = Fluid3D([9834,10458,10114,9633],0); -ELEMENTS[53357] = Fluid3D([9834,10458,9633,10313],0); -ELEMENTS[53358] = Fluid3D([18056,17818,18180,18136],0); -ELEMENTS[53359] = Fluid3D([10595,11432,11704,10894],0); -ELEMENTS[53360] = Fluid3D([16049,16265,16621,16549],0); -ELEMENTS[53361] = Fluid3D([16621,16049,16549,16352],0); -ELEMENTS[53362] = Fluid3D([16049,16549,16352,16279],0); -ELEMENTS[53363] = Fluid3D([16049,16549,16279,16120],0); -ELEMENTS[53364] = Fluid3D([16279,16049,16120,16090],0); -ELEMENTS[53365] = Fluid3D([16549,16352,16279,16647],0); -ELEMENTS[53366] = Fluid3D([16279,16549,16647,16120],0); -ELEMENTS[53367] = Fluid3D([16352,16279,16647,16090],0); -ELEMENTS[53368] = Fluid3D([16279,16647,16090,16406],0); -ELEMENTS[53369] = Fluid3D([16352,16279,16090,16049],0); -ELEMENTS[53370] = Fluid3D([16090,16279,16406,16120],0); -ELEMENTS[53371] = Fluid3D([16279,16647,16406,16120],0); -ELEMENTS[53372] = Fluid3D([16049,16265,16549,16120],0); -ELEMENTS[53373] = Fluid3D([16549,16352,16647,16774],0); -ELEMENTS[53374] = Fluid3D([16549,16352,16774,16621],0); -ELEMENTS[53375] = Fluid3D([16774,16549,16621,17029],0); -ELEMENTS[53376] = Fluid3D([16265,16621,16549,16754],0); -ELEMENTS[53377] = Fluid3D([16265,16621,16754,16392],0); -ELEMENTS[53378] = Fluid3D([16754,16265,16392,16553],0); -ELEMENTS[53379] = Fluid3D([16265,16621,16392,15891],0); -ELEMENTS[53380] = Fluid3D([16392,16265,15891,16181],0); -ELEMENTS[53381] = Fluid3D([16265,16392,16553,16181],0); -ELEMENTS[53382] = Fluid3D([16621,16549,16754,17029],0); -ELEMENTS[53383] = Fluid3D([12161,12448,12473,13412],0); -ELEMENTS[53384] = Fluid3D([1938,2061,2032,1932],0); -ELEMENTS[53385] = Fluid3D([1938,2061,1932,1878],0); -ELEMENTS[53386] = Fluid3D([2032,1938,1932,1840],0); -ELEMENTS[53387] = Fluid3D([17765,17490,17883,17649],0); -ELEMENTS[53388] = Fluid3D([7968,7407,7402,8054],0); -ELEMENTS[53389] = Fluid3D([7407,7402,8054,7024],0); -ELEMENTS[53390] = Fluid3D([10625,10472,11489,11188],0); -ELEMENTS[53391] = Fluid3D([14324,14806,14330,14699],0); -ELEMENTS[53392] = Fluid3D([14324,14806,14699,14611],0); -ELEMENTS[53393] = Fluid3D([14699,14324,14611,14557],0); -ELEMENTS[53394] = Fluid3D([16022,15566,15878,15974],0); -ELEMENTS[53395] = Fluid3D([5842,5451,6039,6003],0); -ELEMENTS[53396] = Fluid3D([5842,5451,6003,6047],0); -ELEMENTS[53397] = Fluid3D([6003,5842,6047,6638],0); -ELEMENTS[53398] = Fluid3D([6047,6003,6638,5806],0); -ELEMENTS[53399] = Fluid3D([5451,6039,6003,5806],0); -ELEMENTS[53400] = Fluid3D([6003,5451,5806,6047],0); -ELEMENTS[53401] = Fluid3D([6039,5842,6003,6339],0); -ELEMENTS[53402] = Fluid3D([6003,6039,6339,5806],0); -ELEMENTS[53403] = Fluid3D([6339,6003,5806,6638],0); -ELEMENTS[53404] = Fluid3D([6339,6003,6638,5842],0); -ELEMENTS[53405] = Fluid3D([5806,6339,6638,6618],0); -ELEMENTS[53406] = Fluid3D([6339,6638,6618,6887],0); -ELEMENTS[53407] = Fluid3D([11235,10216,11239,10605],0); -ELEMENTS[53408] = Fluid3D([17652,17497,17410,17514],0); -ELEMENTS[53409] = Fluid3D([14900,14634,15170,15290],0); -ELEMENTS[53410] = Fluid3D([9368,9649,8608,8997],0); -ELEMENTS[53411] = Fluid3D([9368,9649,8997,9990],0); -ELEMENTS[53412] = Fluid3D([16835,16561,17048,16892],0); -ELEMENTS[53413] = Fluid3D([6284,6182,6302,5754],0); -ELEMENTS[53414] = Fluid3D([2911,2634,2976,2733],0); -ELEMENTS[53415] = Fluid3D([18454,18504,18447,18604],0); -ELEMENTS[53416] = Fluid3D([5422,5258,5995,5610],0); -ELEMENTS[53417] = Fluid3D([5995,5422,5610,6008],0); -ELEMENTS[53418] = Fluid3D([7393,7223,8103,7216],0); -ELEMENTS[53419] = Fluid3D([7393,7223,7216,6490],0); -ELEMENTS[53420] = Fluid3D([8103,7393,7216,7307],0); -ELEMENTS[53421] = Fluid3D([7393,7216,7307,6754],0); -ELEMENTS[53422] = Fluid3D([7307,7393,6754,6611],0); -ELEMENTS[53423] = Fluid3D([7216,7307,6754,6679],0); -ELEMENTS[53424] = Fluid3D([7393,7216,6754,6490],0); -ELEMENTS[53425] = Fluid3D([7216,6754,6490,6679],0); -ELEMENTS[53426] = Fluid3D([8103,7393,7307,8188],0); -ELEMENTS[53427] = Fluid3D([6754,7393,6490,6174],0); -ELEMENTS[53428] = Fluid3D([6490,6754,6174,6308],0); -ELEMENTS[53429] = Fluid3D([6754,6174,6308,6611],0); -ELEMENTS[53430] = Fluid3D([6174,6308,6611,5828],0); -ELEMENTS[53431] = Fluid3D([7216,7307,6679,7644],0); -ELEMENTS[53432] = Fluid3D([7216,7307,7644,8103],0); -ELEMENTS[53433] = Fluid3D([6679,7216,7644,7283],0); -ELEMENTS[53434] = Fluid3D([6754,6174,6611,7393],0); -ELEMENTS[53435] = Fluid3D([7644,7216,8103,7312],0); -ELEMENTS[53436] = Fluid3D([7393,7307,8188,7820],0); -ELEMENTS[53437] = Fluid3D([7644,7216,7312,7283],0); -ELEMENTS[53438] = Fluid3D([6308,6754,6611,7307],0); -ELEMENTS[53439] = Fluid3D([6308,6754,7307,6679],0); -ELEMENTS[53440] = Fluid3D([6611,6174,5828,5953],0); -ELEMENTS[53441] = Fluid3D([6490,6754,6308,6679],0); -ELEMENTS[53442] = Fluid3D([7216,7312,7283,6679],0); -ELEMENTS[53443] = Fluid3D([15116,14979,15702,15164],0); -ELEMENTS[53444] = Fluid3D([14979,15702,15164,15477],0); -ELEMENTS[53445] = Fluid3D([15164,14979,15477,14540],0); -ELEMENTS[53446] = Fluid3D([15702,15164,15477,15747],0); -ELEMENTS[53447] = Fluid3D([15164,14979,14540,14397],0); -ELEMENTS[53448] = Fluid3D([15164,15477,15747,15396],0); -ELEMENTS[53449] = Fluid3D([15477,15164,14540,15066],0); -ELEMENTS[53450] = Fluid3D([15477,15164,15066,15396],0); -ELEMENTS[53451] = Fluid3D([15164,14540,15066,14528],0); -ELEMENTS[53452] = Fluid3D([15066,15164,14528,15156],0); -ELEMENTS[53453] = Fluid3D([14528,15066,15156,15396],0); -ELEMENTS[53454] = Fluid3D([14528,15066,15396,14391],0); -ELEMENTS[53455] = Fluid3D([15066,15164,15156,15396],0); -ELEMENTS[53456] = Fluid3D([14528,15066,14391,14540],0); -ELEMENTS[53457] = Fluid3D([15066,14391,14540,15402],0); -ELEMENTS[53458] = Fluid3D([2432,2638,2794,2527],0); -ELEMENTS[53459] = Fluid3D([6428,6208,5824,6520],0); -ELEMENTS[53460] = Fluid3D([16694,16795,16647,16406],0); -ELEMENTS[53461] = Fluid3D([16647,16694,16406,16120],0); -ELEMENTS[53462] = Fluid3D([12605,11829,12248,11824],0); -ELEMENTS[53463] = Fluid3D([12605,11829,11824,12240],0); -ELEMENTS[53464] = Fluid3D([12248,12605,11824,12873],0); -ELEMENTS[53465] = Fluid3D([12248,12605,12873,13147],0); -ELEMENTS[53466] = Fluid3D([12873,12248,13147,13407],0); -ELEMENTS[53467] = Fluid3D([12605,11824,12873,11795],0); -ELEMENTS[53468] = Fluid3D([11824,12248,12873,12034],0); -ELEMENTS[53469] = Fluid3D([12248,12873,12034,13407],0); -ELEMENTS[53470] = Fluid3D([11824,12248,12034,11080],0); -ELEMENTS[53471] = Fluid3D([12034,11824,11080,11795],0); -ELEMENTS[53472] = Fluid3D([11824,11080,11795,10969],0); -ELEMENTS[53473] = Fluid3D([12873,11824,12034,11795],0); -ELEMENTS[53474] = Fluid3D([15709,15990,16232,16205],0); -ELEMENTS[53475] = Fluid3D([15709,15990,16205,15774],0); -ELEMENTS[53476] = Fluid3D([11321,12141,11616,11276],0); -ELEMENTS[53477] = Fluid3D([12141,11616,11276,12056],0); -ELEMENTS[53478] = Fluid3D([16104,15714,15389,15972],0); -ELEMENTS[53479] = Fluid3D([15338,15244,15936,15533],0); -ELEMENTS[53480] = Fluid3D([15900,15579,15841,15145],0); -ELEMENTS[53481] = Fluid3D([5090,4485,4829,4731],0); -ELEMENTS[53482] = Fluid3D([17714,17830,17943,18092],0); -ELEMENTS[53483] = Fluid3D([17714,17830,18092,18037],0); -ELEMENTS[53484] = Fluid3D([17581,17651,17245,17531],0); -ELEMENTS[53485] = Fluid3D([17581,17651,17531,17878],0); -ELEMENTS[53486] = Fluid3D([17581,17651,17878,17945],0); -ELEMENTS[53487] = Fluid3D([17531,17581,17878,17725],0); -ELEMENTS[53488] = Fluid3D([17581,17878,17725,17945],0); -ELEMENTS[53489] = Fluid3D([3201,3169,2949,3473],0); -ELEMENTS[53490] = Fluid3D([15885,15292,15641,15404],0); -ELEMENTS[53491] = Fluid3D([15885,15292,15404,15239],0); -ELEMENTS[53492] = Fluid3D([15292,15641,15404,14607],0); -ELEMENTS[53493] = Fluid3D([9325,8576,8538,9692],0); -ELEMENTS[53494] = Fluid3D([8538,9325,9692,9161],0); -ELEMENTS[53495] = Fluid3D([17325,16882,17178,17176],0); -ELEMENTS[53496] = Fluid3D([17178,17325,17176,17690],0); -ELEMENTS[53497] = Fluid3D([9997,10362,9590,9140],0); -ELEMENTS[53498] = Fluid3D([9590,9997,9140,9804],0); -ELEMENTS[53499] = Fluid3D([9590,9997,9804,11033],0); -ELEMENTS[53500] = Fluid3D([9997,9140,9804,9771],0); -ELEMENTS[53501] = Fluid3D([9804,9997,9771,10452],0); -ELEMENTS[53502] = Fluid3D([9997,9140,9771,10494],0); -ELEMENTS[53503] = Fluid3D([9771,9997,10494,10452],0); -ELEMENTS[53504] = Fluid3D([9804,9997,10452,11033],0); -ELEMENTS[53505] = Fluid3D([10494,9771,10452,10862],0); -ELEMENTS[53506] = Fluid3D([7804,8364,7969,7252],0); -ELEMENTS[53507] = Fluid3D([5350,5086,5452,4710],0); -ELEMENTS[53508] = Fluid3D([10837,11871,11516,11683],0); -ELEMENTS[53509] = Fluid3D([12041,12116,11982,12432],0); -ELEMENTS[53510] = Fluid3D([3485,3515,3829,3688],0); -ELEMENTS[53511] = Fluid3D([7119,7613,6806,6332],0); -ELEMENTS[53512] = Fluid3D([5569,5288,4944,4825],0); -ELEMENTS[53513] = Fluid3D([13335,12899,13171,12386],0); -ELEMENTS[53514] = Fluid3D([13335,12899,12386,12579],0); -ELEMENTS[53515] = Fluid3D([13335,12899,12579,13555],0); -ELEMENTS[53516] = Fluid3D([17657,17883,18006,17771],0); -ELEMENTS[53517] = Fluid3D([17657,17883,17771,17389],0); -ELEMENTS[53518] = Fluid3D([17657,17883,17389,17374],0); -ELEMENTS[53519] = Fluid3D([17389,17657,17374,17315],0); -ELEMENTS[53520] = Fluid3D([17389,17657,17315,17556],0); -ELEMENTS[53521] = Fluid3D([17389,17657,17556,17771],0); -ELEMENTS[53522] = Fluid3D([17657,17556,17771,18006],0); -ELEMENTS[53523] = Fluid3D([17556,17389,17771,17508],0); -ELEMENTS[53524] = Fluid3D([17657,17315,17556,17545],0); -ELEMENTS[53525] = Fluid3D([17315,17556,17545,17423],0); -ELEMENTS[53526] = Fluid3D([17556,17545,17423,17898],0); -ELEMENTS[53527] = Fluid3D([17657,17315,17545,17451],0); -ELEMENTS[53528] = Fluid3D([17556,17657,17545,18006],0); -ELEMENTS[53529] = Fluid3D([17315,17556,17423,17144],0); -ELEMENTS[53530] = Fluid3D([17556,17423,17144,17654],0); -ELEMENTS[53531] = Fluid3D([17556,17423,17654,17898],0); -ELEMENTS[53532] = Fluid3D([17545,17315,17423,17003],0); -ELEMENTS[53533] = Fluid3D([17771,17556,17508,17654],0); -ELEMENTS[53534] = Fluid3D([17771,17556,17654,17898],0); -ELEMENTS[53535] = Fluid3D([17771,17556,17898,18006],0); -ELEMENTS[53536] = Fluid3D([17315,17389,17556,17144],0); -ELEMENTS[53537] = Fluid3D([17315,17545,17451,17269],0); -ELEMENTS[53538] = Fluid3D([17315,17545,17269,17003],0); -ELEMENTS[53539] = Fluid3D([17374,17389,17315,17006],0); -ELEMENTS[53540] = Fluid3D([17423,17144,17654,17457],0); -ELEMENTS[53541] = Fluid3D([17657,17374,17315,17451],0); -ELEMENTS[53542] = Fluid3D([11722,10500,11223,11566],0); -ELEMENTS[53543] = Fluid3D([6031,6662,6306,5887],0); -ELEMENTS[53544] = Fluid3D([16423,16082,16192,16836],0); -ELEMENTS[53545] = Fluid3D([5776,5526,5729,5224],0); -ELEMENTS[53546] = Fluid3D([9519,9685,10293,10336],0); -ELEMENTS[53547] = Fluid3D([12734,11874,12080,11582],0); -ELEMENTS[53548] = Fluid3D([11874,12080,11582,11117],0); -ELEMENTS[53549] = Fluid3D([11874,12080,11117,10978],0); -ELEMENTS[53550] = Fluid3D([11117,11874,10978,11582],0); -ELEMENTS[53551] = Fluid3D([2292,2275,2185,2485],0); -ELEMENTS[53552] = Fluid3D([13077,13625,12846,13393],0); -ELEMENTS[53553] = Fluid3D([12846,13077,13393,12327],0); -ELEMENTS[53554] = Fluid3D([12846,13077,12327,11739],0); -ELEMENTS[53555] = Fluid3D([9986,10543,11073,9549],0); -ELEMENTS[53556] = Fluid3D([6113,6341,5833,5490],0); -ELEMENTS[53557] = Fluid3D([6113,6341,5490,5506],0); -ELEMENTS[53558] = Fluid3D([5833,6113,5490,6218],0); -ELEMENTS[53559] = Fluid3D([17215,17100,17359,17566],0); -ELEMENTS[53560] = Fluid3D([17100,17359,17566,17287],0); -ELEMENTS[53561] = Fluid3D([17100,17359,17287,17055],0); -ELEMENTS[53562] = Fluid3D([17026,17242,17391,17570],0); -ELEMENTS[53563] = Fluid3D([11532,12611,12334,12113],0); -ELEMENTS[53564] = Fluid3D([10267,9389,9725,8977],0); -ELEMENTS[53565] = Fluid3D([16236,16653,16823,16460],0); -ELEMENTS[53566] = Fluid3D([16236,16653,16460,16293],0); -ELEMENTS[53567] = Fluid3D([16460,16236,16293,15675],0); -ELEMENTS[53568] = Fluid3D([16236,16653,16293,15880],0); -ELEMENTS[53569] = Fluid3D([16823,16236,16460,16005],0); -ELEMENTS[53570] = Fluid3D([16236,16460,16005,15675],0); -ELEMENTS[53571] = Fluid3D([16902,16770,16796,16350],0); -ELEMENTS[53572] = Fluid3D([7900,8491,7487,8044],0); -ELEMENTS[53573] = Fluid3D([7900,8491,8044,8764],0); -ELEMENTS[53574] = Fluid3D([10845,9965,9710,9780],0); -ELEMENTS[53575] = Fluid3D([7451,7705,6892,6918],0); -ELEMENTS[53576] = Fluid3D([7775,7153,6776,7445],0); -ELEMENTS[53577] = Fluid3D([8256,7928,7197,7511],0); -ELEMENTS[53578] = Fluid3D([7928,7197,7511,7347],0); -ELEMENTS[53579] = Fluid3D([7197,7511,7347,6636],0); -ELEMENTS[53580] = Fluid3D([7928,7197,7347,6960],0); -ELEMENTS[53581] = Fluid3D([7197,7347,6960,6306],0); -ELEMENTS[53582] = Fluid3D([7197,7511,6636,7052],0); -ELEMENTS[53583] = Fluid3D([7197,7511,7052,7839],0); -ELEMENTS[53584] = Fluid3D([7197,8256,7511,7839],0); -ELEMENTS[53585] = Fluid3D([7511,6636,7052,6951],0); -ELEMENTS[53586] = Fluid3D([13159,13367,12523,12380],0); -ELEMENTS[53587] = Fluid3D([4290,4081,4118,3933],0); -ELEMENTS[53588] = Fluid3D([3977,3974,4259,4425],0); -ELEMENTS[53589] = Fluid3D([4259,3977,4425,4587],0); -ELEMENTS[53590] = Fluid3D([4259,3977,4587,4171],0); -ELEMENTS[53591] = Fluid3D([3123,3179,3261,2970],0); -ELEMENTS[53592] = Fluid3D([3179,3261,2970,3151],0); -ELEMENTS[53593] = Fluid3D([3261,2970,3151,2994],0); -ELEMENTS[53594] = Fluid3D([3261,3123,2970,3127],0); -ELEMENTS[53595] = Fluid3D([3179,3261,3151,3450],0); -ELEMENTS[53596] = Fluid3D([3261,3151,3450,3262],0); -ELEMENTS[53597] = Fluid3D([3261,3151,3262,2994],0); -ELEMENTS[53598] = Fluid3D([3450,3261,3262,3606],0); -ELEMENTS[53599] = Fluid3D([3261,3262,3606,3592],0); -ELEMENTS[53600] = Fluid3D([3262,3606,3592,3746],0); -ELEMENTS[53601] = Fluid3D([3606,3592,3746,4091],0); -ELEMENTS[53602] = Fluid3D([3262,3606,3746,3450],0); -ELEMENTS[53603] = Fluid3D([3151,3450,3262,2994],0); -ELEMENTS[53604] = Fluid3D([3606,3746,3450,3839],0); -ELEMENTS[53605] = Fluid3D([3606,3746,3839,4091],0); -ELEMENTS[53606] = Fluid3D([3606,3261,3592,3419],0); -ELEMENTS[53607] = Fluid3D([3606,3261,3419,3839],0); -ELEMENTS[53608] = Fluid3D([3450,3606,3839,3261],0); -ELEMENTS[53609] = Fluid3D([3151,3450,2994,3490],0); -ELEMENTS[53610] = Fluid3D([3606,3592,4091,3842],0); -ELEMENTS[53611] = Fluid3D([3606,3592,3842,3419],0); -ELEMENTS[53612] = Fluid3D([3842,3606,3419,3839],0); -ELEMENTS[53613] = Fluid3D([3842,3606,3839,4091],0); -ELEMENTS[53614] = Fluid3D([3151,3450,3490,3402],0); -ELEMENTS[53615] = Fluid3D([3151,3450,3402,3116],0); -ELEMENTS[53616] = Fluid3D([3261,3262,3592,3127],0); -ELEMENTS[53617] = Fluid3D([3261,3262,3127,2849],0); -ELEMENTS[53618] = Fluid3D([3261,3262,2849,2994],0); -ELEMENTS[53619] = Fluid3D([2970,3261,3127,2849],0); -ELEMENTS[53620] = Fluid3D([2970,3261,2849,2994],0); -ELEMENTS[53621] = Fluid3D([3123,3179,2970,2739],0); -ELEMENTS[53622] = Fluid3D([2970,3179,3151,3116],0); -ELEMENTS[53623] = Fluid3D([3179,2970,2739,3116],0); -ELEMENTS[53624] = Fluid3D([5613,5449,6181,5754],0); -ELEMENTS[53625] = Fluid3D([8500,8552,9532,8685],0); -ELEMENTS[53626] = Fluid3D([8323,9191,8882,8429],0); -ELEMENTS[53627] = Fluid3D([11198,10484,11470,11191],0); -ELEMENTS[53628] = Fluid3D([3965,3549,3464,3684],0); -ELEMENTS[53629] = Fluid3D([7401,8066,7681,6997],0); -ELEMENTS[53630] = Fluid3D([2012,2026,2193,2197],0); -ELEMENTS[53631] = Fluid3D([2193,2012,2197,1969],0); -ELEMENTS[53632] = Fluid3D([5256,5878,5756,5885],0); -ELEMENTS[53633] = Fluid3D([17305,17103,16859,17204],0); -ELEMENTS[53634] = Fluid3D([17305,17103,17204,17595],0); -ELEMENTS[53635] = Fluid3D([17811,18100,18155,17939],0); -ELEMENTS[53636] = Fluid3D([10078,10591,10351,9918],0); -ELEMENTS[53637] = Fluid3D([10078,10591,9918,9614],0); -ELEMENTS[53638] = Fluid3D([10575,10764,11620,11034],0); -ELEMENTS[53639] = Fluid3D([11620,10575,11034,10800],0); -ELEMENTS[53640] = Fluid3D([13509,13868,14361,14701],0); -ELEMENTS[53641] = Fluid3D([13868,14361,14701,14397],0); -ELEMENTS[53642] = Fluid3D([14701,13868,14397,14004],0); -ELEMENTS[53643] = Fluid3D([13868,14361,14397,13955],0); -ELEMENTS[53644] = Fluid3D([7952,8272,8610,8367],0); -ELEMENTS[53645] = Fluid3D([16781,16834,16260,16351],0); -ELEMENTS[53646] = Fluid3D([16260,16781,16351,16718],0); -ELEMENTS[53647] = Fluid3D([12874,12336,12782,13292],0); -ELEMENTS[53648] = Fluid3D([12336,12782,13292,13278],0); -ELEMENTS[53649] = Fluid3D([12874,12336,13292,13452],0); -ELEMENTS[53650] = Fluid3D([13292,12874,13452,13865],0); -ELEMENTS[53651] = Fluid3D([13452,13292,13865,13726],0); -ELEMENTS[53652] = Fluid3D([13292,12874,13865,12782],0); -ELEMENTS[53653] = Fluid3D([12874,13452,13865,13469],0); -ELEMENTS[53654] = Fluid3D([13865,12874,13469,13409],0); -ELEMENTS[53655] = Fluid3D([9175,8398,9098,9330],0); -ELEMENTS[53656] = Fluid3D([11545,11696,12703,12303],0); -ELEMENTS[53657] = Fluid3D([7818,7450,7225,6888],0); -ELEMENTS[53658] = Fluid3D([7225,7818,6888,7588],0); -ELEMENTS[53659] = Fluid3D([16399,16128,15628,16009],0); -ELEMENTS[53660] = Fluid3D([2066,2134,1924,2041],0); -ELEMENTS[53661] = Fluid3D([2134,1924,2041,1911],0); -ELEMENTS[53662] = Fluid3D([2066,2134,2041,2229],0); -ELEMENTS[53663] = Fluid3D([2134,2041,2229,2373],0); -ELEMENTS[53664] = Fluid3D([2041,2134,1911,2214],0); -ELEMENTS[53665] = Fluid3D([15550,15616,15858,15033],0); -ELEMENTS[53666] = Fluid3D([18495,18491,18570,18616],0); -ELEMENTS[53667] = Fluid3D([2402,2567,2317,2751],0); -ELEMENTS[53668] = Fluid3D([10069,9550,9701,10545],0); -ELEMENTS[53669] = Fluid3D([13672,13493,14179,14281],0); -ELEMENTS[53670] = Fluid3D([11551,11782,11560,12933],0); -ELEMENTS[53671] = Fluid3D([11087,11261,10289,10949],0); -ELEMENTS[53672] = Fluid3D([11261,10289,10949,10795],0); -ELEMENTS[53673] = Fluid3D([10949,11261,10795,12120],0); -ELEMENTS[53674] = Fluid3D([10289,10949,10795,10572],0); -ELEMENTS[53675] = Fluid3D([10949,10795,10572,11294],0); -ELEMENTS[53676] = Fluid3D([10572,10949,11294,10430],0); -ELEMENTS[53677] = Fluid3D([10949,10795,11294,12120],0); -ELEMENTS[53678] = Fluid3D([10795,10572,11294,10822],0); -ELEMENTS[53679] = Fluid3D([10572,11294,10822,10988],0); -ELEMENTS[53680] = Fluid3D([10572,11294,10988,10430],0); -ELEMENTS[53681] = Fluid3D([10289,11087,10949,10344],0); -ELEMENTS[53682] = Fluid3D([10949,10289,10344,10572],0); -ELEMENTS[53683] = Fluid3D([10344,10949,10572,10430],0); -ELEMENTS[53684] = Fluid3D([11087,10949,10344,10430],0); -ELEMENTS[53685] = Fluid3D([10289,11087,10344,10544],0); -ELEMENTS[53686] = Fluid3D([7107,7364,6523,7372],0); -ELEMENTS[53687] = Fluid3D([7364,6523,7372,6835],0); -ELEMENTS[53688] = Fluid3D([11379,11339,10520,11044],0); -ELEMENTS[53689] = Fluid3D([11339,10520,11044,11534],0); -ELEMENTS[53690] = Fluid3D([17515,17470,17441,17283],0); -ELEMENTS[53691] = Fluid3D([14891,14543,15086,14807],0); -ELEMENTS[53692] = Fluid3D([14543,15086,14807,15339],0); -ELEMENTS[53693] = Fluid3D([15086,14807,15339,15154],0); -ELEMENTS[53694] = Fluid3D([15086,14807,15154,14891],0); -ELEMENTS[53695] = Fluid3D([15339,15086,15154,15664],0); -ELEMENTS[53696] = Fluid3D([15086,15154,15664,14891],0); -ELEMENTS[53697] = Fluid3D([2999,2827,2820,2532],0); -ELEMENTS[53698] = Fluid3D([4222,4019,3723,3815],0); -ELEMENTS[53699] = Fluid3D([15984,16074,15630,16238],0); -ELEMENTS[53700] = Fluid3D([15630,15984,16238,15919],0); -ELEMENTS[53701] = Fluid3D([15630,15984,15919,15473],0); -ELEMENTS[53702] = Fluid3D([16238,15630,15919,15651],0); -ELEMENTS[53703] = Fluid3D([15984,16238,15919,16252],0); -ELEMENTS[53704] = Fluid3D([15919,15984,16252,15473],0); -ELEMENTS[53705] = Fluid3D([16238,15919,16252,16240],0); -ELEMENTS[53706] = Fluid3D([15919,16252,16240,15622],0); -ELEMENTS[53707] = Fluid3D([16240,15919,15622,15651],0); -ELEMENTS[53708] = Fluid3D([16238,15919,16240,15651],0); -ELEMENTS[53709] = Fluid3D([15919,16252,15622,15473],0); -ELEMENTS[53710] = Fluid3D([15919,15622,15651,15216],0); -ELEMENTS[53711] = Fluid3D([15919,15622,15216,15473],0); -ELEMENTS[53712] = Fluid3D([16074,15630,16238,16221],0); -ELEMENTS[53713] = Fluid3D([16238,16074,16221,16674],0); -ELEMENTS[53714] = Fluid3D([16221,16238,16674,16535],0); -ELEMENTS[53715] = Fluid3D([16221,16238,16535,15986],0); -ELEMENTS[53716] = Fluid3D([16238,16674,16535,16240],0); -ELEMENTS[53717] = Fluid3D([15630,16238,16221,15651],0); -ELEMENTS[53718] = Fluid3D([16535,16238,16240,15986],0); -ELEMENTS[53719] = Fluid3D([5225,4968,4603,5077],0); -ELEMENTS[53720] = Fluid3D([7959,8297,7855,8603],0); -ELEMENTS[53721] = Fluid3D([17175,17165,17451,17475],0); -ELEMENTS[53722] = Fluid3D([3419,3179,3794,3600],0); -ELEMENTS[53723] = Fluid3D([8341,8227,8515,7409],0); -ELEMENTS[53724] = Fluid3D([7106,6987,6316,6362],0); -ELEMENTS[53725] = Fluid3D([11045,10283,10134,9894],0); -ELEMENTS[53726] = Fluid3D([17866,17887,18086,17720],0); -ELEMENTS[53727] = Fluid3D([12953,13317,13914,13680],0); -ELEMENTS[53728] = Fluid3D([7603,8109,7882,7635],0); -ELEMENTS[53729] = Fluid3D([18551,18644,18591,18583],0); -ELEMENTS[53730] = Fluid3D([17634,17885,17989,17751],0); -ELEMENTS[53731] = Fluid3D([6151,6780,5930,6015],0); -ELEMENTS[53732] = Fluid3D([5930,6151,6015,5424],0); -ELEMENTS[53733] = Fluid3D([6151,6015,5424,5527],0); -ELEMENTS[53734] = Fluid3D([6151,6780,6015,6680],0); -ELEMENTS[53735] = Fluid3D([10924,11776,11917,11238],0); -ELEMENTS[53736] = Fluid3D([15568,15737,15715,16327],0); -ELEMENTS[53737] = Fluid3D([17499,17779,17848,17656],0); -ELEMENTS[53738] = Fluid3D([4303,3984,4486,4126],0); -ELEMENTS[53739] = Fluid3D([6038,6591,5937,5977],0); -ELEMENTS[53740] = Fluid3D([6038,6591,5977,6815],0); -ELEMENTS[53741] = Fluid3D([6591,5977,6815,7146],0); -ELEMENTS[53742] = Fluid3D([6591,5937,5977,6255],0); -ELEMENTS[53743] = Fluid3D([5937,6038,5977,5282],0); -ELEMENTS[53744] = Fluid3D([3371,3608,3219,3614],0); -ELEMENTS[53745] = Fluid3D([6112,6200,5992,5315],0); -ELEMENTS[53746] = Fluid3D([10036,10480,10718,10922],0); -ELEMENTS[53747] = Fluid3D([8726,9122,8144,8258],0); -ELEMENTS[53748] = Fluid3D([12541,12257,12887,13299],0); -ELEMENTS[53749] = Fluid3D([5897,5713,6140,5626],0); -ELEMENTS[53750] = Fluid3D([13997,13700,14254,14310],0); -ELEMENTS[53751] = Fluid3D([1711,1816,1804,1875],0); -ELEMENTS[53752] = Fluid3D([1711,1816,1875,1717],0); -ELEMENTS[53753] = Fluid3D([3643,3577,3336,4032],0); -ELEMENTS[53754] = Fluid3D([9504,9532,8500,9083],0); -ELEMENTS[53755] = Fluid3D([4012,3597,3797,3466],0); -ELEMENTS[53756] = Fluid3D([4012,3597,3466,3696],0); -ELEMENTS[53757] = Fluid3D([7450,7069,6923,6604],0); -ELEMENTS[53758] = Fluid3D([7450,7069,6604,6405],0); -ELEMENTS[53759] = Fluid3D([6574,6145,6907,6019],0); -ELEMENTS[53760] = Fluid3D([6907,6574,6019,6613],0); -ELEMENTS[53761] = Fluid3D([6907,6574,6613,7269],0); -ELEMENTS[53762] = Fluid3D([17361,16916,17240,17043],0); -ELEMENTS[53763] = Fluid3D([3616,3989,3802,3403],0); -ELEMENTS[53764] = Fluid3D([3802,3616,3403,3128],0); -ELEMENTS[53765] = Fluid3D([4051,3601,3958,3892],0); -ELEMENTS[53766] = Fluid3D([4051,3601,3892,3950],0); -ELEMENTS[53767] = Fluid3D([3892,4051,3950,4150],0); -ELEMENTS[53768] = Fluid3D([3950,3892,4150,3562],0); -ELEMENTS[53769] = Fluid3D([3950,3892,3562,3601],0); -ELEMENTS[53770] = Fluid3D([3892,4150,3562,3765],0); -ELEMENTS[53771] = Fluid3D([3892,4150,3765,3958],0); -ELEMENTS[53772] = Fluid3D([3562,3892,3765,3601],0); -ELEMENTS[53773] = Fluid3D([3892,4051,4150,3958],0); -ELEMENTS[53774] = Fluid3D([3765,3892,3958,3601],0); -ELEMENTS[53775] = Fluid3D([6692,7143,7351,6462],0); -ELEMENTS[53776] = Fluid3D([4837,4941,5378,5372],0); -ELEMENTS[53777] = Fluid3D([4941,5378,5372,5136],0); -ELEMENTS[53778] = Fluid3D([5378,4837,5372,5645],0); -ELEMENTS[53779] = Fluid3D([5372,5378,5645,6006],0); -ELEMENTS[53780] = Fluid3D([5372,5378,6006,5785],0); -ELEMENTS[53781] = Fluid3D([6006,5372,5785,6138],0); -ELEMENTS[53782] = Fluid3D([5372,5785,6138,5884],0); -ELEMENTS[53783] = Fluid3D([6138,5372,5884,5645],0); -ELEMENTS[53784] = Fluid3D([5785,6138,5884,6494],0); -ELEMENTS[53785] = Fluid3D([6138,5884,6494,6627],0); -ELEMENTS[53786] = Fluid3D([5785,6138,6494,6006],0); -ELEMENTS[53787] = Fluid3D([6006,5372,6138,5645],0); -ELEMENTS[53788] = Fluid3D([6138,5884,6627,6206],0); -ELEMENTS[53789] = Fluid3D([6494,6138,6627,6943],0); -ELEMENTS[53790] = Fluid3D([6494,6138,6943,6709],0); -ELEMENTS[53791] = Fluid3D([5372,5378,5785,5577],0); -ELEMENTS[53792] = Fluid3D([5372,5378,5577,5136],0); -ELEMENTS[53793] = Fluid3D([5785,5372,5577,5214],0); -ELEMENTS[53794] = Fluid3D([5785,5372,5214,5884],0); -ELEMENTS[53795] = Fluid3D([5372,5214,5884,5322],0); -ELEMENTS[53796] = Fluid3D([5577,5372,5136,5214],0); -ELEMENTS[53797] = Fluid3D([6138,6494,6006,6709],0); -ELEMENTS[53798] = Fluid3D([6627,6494,6943,7371],0); -ELEMENTS[53799] = Fluid3D([6494,6943,7371,7262],0); -ELEMENTS[53800] = Fluid3D([6943,6627,7371,7355],0); -ELEMENTS[53801] = Fluid3D([7371,6943,7355,7526],0); -ELEMENTS[53802] = Fluid3D([6943,7355,7526,6709],0); -ELEMENTS[53803] = Fluid3D([7371,6943,7526,7262],0); -ELEMENTS[53804] = Fluid3D([7355,7371,7526,8043],0); -ELEMENTS[53805] = Fluid3D([7526,7355,8043,7690],0); -ELEMENTS[53806] = Fluid3D([6943,6627,7355,6744],0); -ELEMENTS[53807] = Fluid3D([7355,6943,6744,6709],0); -ELEMENTS[53808] = Fluid3D([7526,7371,7262,8149],0); -ELEMENTS[53809] = Fluid3D([7355,7371,8043,7523],0); -ELEMENTS[53810] = Fluid3D([7526,7371,8149,8043],0); -ELEMENTS[53811] = Fluid3D([5372,4941,5136,4837],0); -ELEMENTS[53812] = Fluid3D([7262,7526,8149,7425],0); -ELEMENTS[53813] = Fluid3D([7262,7526,7425,6943],0); -ELEMENTS[53814] = Fluid3D([7526,7425,6943,6709],0); -ELEMENTS[53815] = Fluid3D([7526,7425,6709,7783],0); -ELEMENTS[53816] = Fluid3D([7526,7425,7783,8520],0); -ELEMENTS[53817] = Fluid3D([7783,7526,8520,8043],0); -ELEMENTS[53818] = Fluid3D([7783,7526,8043,7690],0); -ELEMENTS[53819] = Fluid3D([7526,7425,8520,8149],0); -ELEMENTS[53820] = Fluid3D([8520,7526,8149,8043],0); -ELEMENTS[53821] = Fluid3D([6943,6744,6709,6138],0); -ELEMENTS[53822] = Fluid3D([6138,6627,6943,6744],0); -ELEMENTS[53823] = Fluid3D([6709,7526,7783,7690],0); -ELEMENTS[53824] = Fluid3D([7425,7783,8520,8365],0); -ELEMENTS[53825] = Fluid3D([5372,5136,5214,4617],0); -ELEMENTS[53826] = Fluid3D([5870,6044,5808,6619],0); -ELEMENTS[53827] = Fluid3D([18549,18450,18586,18535],0); -ELEMENTS[53828] = Fluid3D([18586,18549,18535,18638],0); -ELEMENTS[53829] = Fluid3D([16068,15757,15565,15550],0); -ELEMENTS[53830] = Fluid3D([15565,16068,15550,16194],0); -ELEMENTS[53831] = Fluid3D([7470,7762,7146,7594],0); -ELEMENTS[53832] = Fluid3D([13076,13575,14018,13030],0); -ELEMENTS[53833] = Fluid3D([14018,13076,13030,13825],0); -ELEMENTS[53834] = Fluid3D([13076,13575,13030,13034],0); -ELEMENTS[53835] = Fluid3D([13030,13076,13034,12128],0); -ELEMENTS[53836] = Fluid3D([13034,13030,12128,12813],0); -ELEMENTS[53837] = Fluid3D([13575,13030,13034,13778],0); -ELEMENTS[53838] = Fluid3D([13030,13034,13778,12813],0); -ELEMENTS[53839] = Fluid3D([13034,13575,13778,13872],0); -ELEMENTS[53840] = Fluid3D([13076,13575,13034,12468],0); -ELEMENTS[53841] = Fluid3D([2555,2770,2905,2943],0); -ELEMENTS[53842] = Fluid3D([14112,14220,13707,14737],0); -ELEMENTS[53843] = Fluid3D([14112,14220,14737,15190],0); -ELEMENTS[53844] = Fluid3D([14220,14737,15190,14906],0); -ELEMENTS[53845] = Fluid3D([14220,14737,14906,14418],0); -ELEMENTS[53846] = Fluid3D([14220,14737,14418,14242],0); -ELEMENTS[53847] = Fluid3D([14220,14737,14242,14187],0); -ELEMENTS[53848] = Fluid3D([14737,14242,14187,14563],0); -ELEMENTS[53849] = Fluid3D([14242,14187,14563,14076],0); -ELEMENTS[53850] = Fluid3D([14187,14563,14076,14410],0); -ELEMENTS[53851] = Fluid3D([14242,14187,14076,13707],0); -ELEMENTS[53852] = Fluid3D([14187,14737,14563,13707],0); -ELEMENTS[53853] = Fluid3D([14563,14187,13707,14410],0); -ELEMENTS[53854] = Fluid3D([14242,14187,13707,13649],0); -ELEMENTS[53855] = Fluid3D([14187,14076,13707,14410],0); -ELEMENTS[53856] = Fluid3D([14187,13707,13649,14220],0); -ELEMENTS[53857] = Fluid3D([7293,7420,7910,8469],0); -ELEMENTS[53858] = Fluid3D([10841,11968,11268,10914],0); -ELEMENTS[53859] = Fluid3D([11394,10716,10390,10477],0); -ELEMENTS[53860] = Fluid3D([3209,2883,2826,2888],0); -ELEMENTS[53861] = Fluid3D([8765,8674,8677,7944],0); -ELEMENTS[53862] = Fluid3D([8674,8677,7944,7875],0); -ELEMENTS[53863] = Fluid3D([8674,8677,7875,9017],0); -ELEMENTS[53864] = Fluid3D([8674,8677,9017,9628],0); -ELEMENTS[53865] = Fluid3D([13573,13137,12994,12255],0); -ELEMENTS[53866] = Fluid3D([6726,7478,7267,6601],0); -ELEMENTS[53867] = Fluid3D([7267,6726,6601,6173],0); -ELEMENTS[53868] = Fluid3D([6726,6601,6173,5848],0); -ELEMENTS[53869] = Fluid3D([6726,7478,6601,6555],0); -ELEMENTS[53870] = Fluid3D([6601,6726,6555,5848],0); -ELEMENTS[53871] = Fluid3D([5878,6239,6250,5661],0); -ELEMENTS[53872] = Fluid3D([6250,5878,5661,5835],0); -ELEMENTS[53873] = Fluid3D([6250,5878,5835,5542],0); -ELEMENTS[53874] = Fluid3D([17970,17858,18051,17822],0); -ELEMENTS[53875] = Fluid3D([16393,16458,16346,15846],0); -ELEMENTS[53876] = Fluid3D([16403,16399,16594,16009],0); -ELEMENTS[53877] = Fluid3D([12718,12432,12939,13768],0); -ELEMENTS[53878] = Fluid3D([6815,7123,6584,5948],0); -ELEMENTS[53879] = Fluid3D([10612,10638,10043,11286],0); -ELEMENTS[53880] = Fluid3D([10612,10638,11286,11820],0); -ELEMENTS[53881] = Fluid3D([10359,9288,9722,9502],0); -ELEMENTS[53882] = Fluid3D([17674,17712,17852,18102],0); -ELEMENTS[53883] = Fluid3D([3151,2800,2970,3116],0); -ELEMENTS[53884] = Fluid3D([17211,17159,17071,16707],0); -ELEMENTS[53885] = Fluid3D([11321,11950,11187,11386],0); -ELEMENTS[53886] = Fluid3D([14590,14239,13821,14412],0); -ELEMENTS[53887] = Fluid3D([14590,14239,14412,15027],0); -ELEMENTS[53888] = Fluid3D([14412,14590,15027,15397],0); -ELEMENTS[53889] = Fluid3D([13821,14590,14412,14100],0); -ELEMENTS[53890] = Fluid3D([14590,14412,14100,14827],0); -ELEMENTS[53891] = Fluid3D([14590,14412,14827,15397],0); -ELEMENTS[53892] = Fluid3D([14100,14590,14827,15040],0); -ELEMENTS[53893] = Fluid3D([14590,14827,15040,15397],0); -ELEMENTS[53894] = Fluid3D([14827,15040,15397,14659],0); -ELEMENTS[53895] = Fluid3D([14827,15040,14659,14129],0); -ELEMENTS[53896] = Fluid3D([14659,14827,14129,14412],0); -ELEMENTS[53897] = Fluid3D([14659,14827,14412,14647],0); -ELEMENTS[53898] = Fluid3D([14659,14827,14647,15397],0); -ELEMENTS[53899] = Fluid3D([14412,14100,14827,14129],0); -ELEMENTS[53900] = Fluid3D([14100,14827,14129,15040],0); -ELEMENTS[53901] = Fluid3D([13821,14590,14100,13910],0); -ELEMENTS[53902] = Fluid3D([14239,14412,15027,14853],0); -ELEMENTS[53903] = Fluid3D([14412,15027,14853,15397],0); -ELEMENTS[53904] = Fluid3D([15027,14239,14853,14669],0); -ELEMENTS[53905] = Fluid3D([14853,15027,14669,15406],0); -ELEMENTS[53906] = Fluid3D([14853,15027,15406,15723],0); -ELEMENTS[53907] = Fluid3D([14853,15027,15723,15397],0); -ELEMENTS[53908] = Fluid3D([14827,14412,14647,15397],0); -ELEMENTS[53909] = Fluid3D([14412,14100,14129,13400],0); -ELEMENTS[53910] = Fluid3D([11272,11483,11897,11949],0); -ELEMENTS[53911] = Fluid3D([11272,11483,11949,12002],0); -ELEMENTS[53912] = Fluid3D([11483,11897,11949,12496],0); -ELEMENTS[53913] = Fluid3D([11949,11483,12496,12002],0); -ELEMENTS[53914] = Fluid3D([12496,11949,12002,12751],0); -ELEMENTS[53915] = Fluid3D([12496,11949,12751,13161],0); -ELEMENTS[53916] = Fluid3D([11949,12002,12751,11272],0); -ELEMENTS[53917] = Fluid3D([11897,11949,12496,13161],0); -ELEMENTS[53918] = Fluid3D([11949,12751,13161,11897],0); -ELEMENTS[53919] = Fluid3D([18200,18276,18240,18098],0); -ELEMENTS[53920] = Fluid3D([12036,11434,12214,12181],0); -ELEMENTS[53921] = Fluid3D([6789,7210,6676,6083],0); -ELEMENTS[53922] = Fluid3D([18423,18395,18400,18216],0); -ELEMENTS[53923] = Fluid3D([10681,10525,9906,11134],0); -ELEMENTS[53924] = Fluid3D([11549,11226,10461,11395],0); -ELEMENTS[53925] = Fluid3D([11862,12451,12912,13099],0); -ELEMENTS[53926] = Fluid3D([9865,10090,10920,10737],0); -ELEMENTS[53927] = Fluid3D([4875,4851,4523,4681],0); -ELEMENTS[53928] = Fluid3D([4523,4875,4681,4979],0); -ELEMENTS[53929] = Fluid3D([17369,17067,17421,16961],0); -ELEMENTS[53930] = Fluid3D([6887,7454,7093,6638],0); -ELEMENTS[53931] = Fluid3D([7454,7093,6638,7538],0); -ELEMENTS[53932] = Fluid3D([2413,2256,2260,2638],0); -ELEMENTS[53933] = Fluid3D([18062,17839,18067,17721],0); -ELEMENTS[53934] = Fluid3D([18079,18267,18256,18408],0); -ELEMENTS[53935] = Fluid3D([18267,18256,18408,18353],0); -ELEMENTS[53936] = Fluid3D([18408,18267,18353,18483],0); -ELEMENTS[53937] = Fluid3D([18267,18256,18353,18181],0); -ELEMENTS[53938] = Fluid3D([9473,9613,10298,10254],0); -ELEMENTS[53939] = Fluid3D([3556,4094,3720,3625],0); -ELEMENTS[53940] = Fluid3D([3720,3556,3625,3245],0); -ELEMENTS[53941] = Fluid3D([3638,3683,3879,3284],0); -ELEMENTS[53942] = Fluid3D([5539,5773,6123,5881],0); -ELEMENTS[53943] = Fluid3D([5539,5773,5881,5153],0); -ELEMENTS[53944] = Fluid3D([8382,9111,9430,8424],0); -ELEMENTS[53945] = Fluid3D([3537,3316,3174,3597],0); -ELEMENTS[53946] = Fluid3D([11783,11950,12524,11386],0); -ELEMENTS[53947] = Fluid3D([17411,17334,17482,17680],0); -ELEMENTS[53948] = Fluid3D([17334,17482,17680,17742],0); -ELEMENTS[53949] = Fluid3D([17334,17482,17742,17290],0); -ELEMENTS[53950] = Fluid3D([5713,5377,5130,5239],0); -ELEMENTS[53951] = Fluid3D([16264,16066,16268,16699],0); -ELEMENTS[53952] = Fluid3D([14738,15305,15051,14414],0); -ELEMENTS[53953] = Fluid3D([3720,4005,3893,3639],0); -ELEMENTS[53954] = Fluid3D([3023,2831,2803,3143],0); -ELEMENTS[53955] = Fluid3D([15470,15866,15728,16149],0); -ELEMENTS[53956] = Fluid3D([15866,15728,16149,16325],0); -ELEMENTS[53957] = Fluid3D([12961,13619,13196,13626],0); -ELEMENTS[53958] = Fluid3D([16822,16958,16661,16546],0); -ELEMENTS[53959] = Fluid3D([16822,16958,16546,16570],0); -ELEMENTS[53960] = Fluid3D([16958,16661,16546,16866],0); -ELEMENTS[53961] = Fluid3D([5937,5729,5282,5529],0); -ELEMENTS[53962] = Fluid3D([13836,13154,13906,13217],0); -ELEMENTS[53963] = Fluid3D([7873,8503,7829,7112],0); -ELEMENTS[53964] = Fluid3D([12530,12607,11774,12554],0); -ELEMENTS[53965] = Fluid3D([11495,10236,11191,10988],0); -ELEMENTS[53966] = Fluid3D([15534,15242,15397,15235],0); -ELEMENTS[53967] = Fluid3D([18163,17962,18068,17867],0); -ELEMENTS[53968] = Fluid3D([18163,17962,17867,18070],0); -ELEMENTS[53969] = Fluid3D([7525,7320,7065,6949],0); -ELEMENTS[53970] = Fluid3D([16576,16900,16972,17136],0); -ELEMENTS[53971] = Fluid3D([7541,7403,6821,7621],0); -ELEMENTS[53972] = Fluid3D([18363,18520,18510,18464],0); -ELEMENTS[53973] = Fluid3D([18510,18363,18464,18287],0); -ELEMENTS[53974] = Fluid3D([16547,16541,17020,16785],0); -ELEMENTS[53975] = Fluid3D([16541,17020,16785,16820],0); -ELEMENTS[53976] = Fluid3D([16547,16541,16785,16454],0); -ELEMENTS[53977] = Fluid3D([16785,16547,16454,16807],0); -ELEMENTS[53978] = Fluid3D([16547,16454,16807,16074],0); -ELEMENTS[53979] = Fluid3D([16785,16547,16807,17020],0); -ELEMENTS[53980] = Fluid3D([16454,16785,16807,17171],0); -ELEMENTS[53981] = Fluid3D([16807,16547,16074,16674],0); -ELEMENTS[53982] = Fluid3D([16807,16547,16674,16985],0); -ELEMENTS[53983] = Fluid3D([16807,16547,16985,17020],0); -ELEMENTS[53984] = Fluid3D([16785,16807,17171,17020],0); -ELEMENTS[53985] = Fluid3D([17171,16785,17020,17206],0); -ELEMENTS[53986] = Fluid3D([17171,16785,17206,16820],0); -ELEMENTS[53987] = Fluid3D([17171,16785,16820,16563],0); -ELEMENTS[53988] = Fluid3D([16785,16820,16563,16541],0); -ELEMENTS[53989] = Fluid3D([17171,16785,16563,16454],0); -ELEMENTS[53990] = Fluid3D([16785,16563,16454,16541],0); -ELEMENTS[53991] = Fluid3D([17732,17512,17899,18014],0); -ELEMENTS[53992] = Fluid3D([11071,10258,10978,11168],0); -ELEMENTS[53993] = Fluid3D([11442,10764,11868,11620],0); -ELEMENTS[53994] = Fluid3D([5122,5135,5558,5811],0); -ELEMENTS[53995] = Fluid3D([17165,17329,17451,17475],0); -ELEMENTS[53996] = Fluid3D([16936,16317,16756,16432],0); -ELEMENTS[53997] = Fluid3D([16611,16515,16194,16955],0); -ELEMENTS[53998] = Fluid3D([5747,5745,5171,5744],0); -ELEMENTS[53999] = Fluid3D([10568,9775,9795,11273],0); -ELEMENTS[54000] = Fluid3D([11135,11790,10928,11164],0); -ELEMENTS[54001] = Fluid3D([13012,13459,13796,13127],0); -ELEMENTS[54002] = Fluid3D([12120,11941,11402,12461],0); -ELEMENTS[54003] = Fluid3D([12120,11941,12461,12964],0); -ELEMENTS[54004] = Fluid3D([12461,12120,12964,12602],0); -ELEMENTS[54005] = Fluid3D([12461,12120,12602,12094],0); -ELEMENTS[54006] = Fluid3D([12120,12964,12602,11976],0); -ELEMENTS[54007] = Fluid3D([18550,18458,18597,18421],0); -ELEMENTS[54008] = Fluid3D([10243,10113,11186,10781],0); -ELEMENTS[54009] = Fluid3D([3863,4110,3788,3779],0); -ELEMENTS[54010] = Fluid3D([10265,10821,10008,9416],0); -ELEMENTS[54011] = Fluid3D([10008,10265,9416,10126],0); -ELEMENTS[54012] = Fluid3D([9416,10008,10126,9160],0); -ELEMENTS[54013] = Fluid3D([10008,10126,9160,9932],0); -ELEMENTS[54014] = Fluid3D([9416,10008,9160,9176],0); -ELEMENTS[54015] = Fluid3D([9416,10008,9176,10821],0); -ELEMENTS[54016] = Fluid3D([11548,12450,12469,12894],0); -ELEMENTS[54017] = Fluid3D([12450,12469,12894,13331],0); -ELEMENTS[54018] = Fluid3D([15050,15074,15589,14844],0); -ELEMENTS[54019] = Fluid3D([15050,15074,14844,14217],0); -ELEMENTS[54020] = Fluid3D([5894,6032,6430,6633],0); -ELEMENTS[54021] = Fluid3D([6032,6430,6633,7217],0); -ELEMENTS[54022] = Fluid3D([5894,6032,6633,6265],0); -ELEMENTS[54023] = Fluid3D([6032,6633,6265,6625],0); -ELEMENTS[54024] = Fluid3D([6032,6633,6625,7217],0); -ELEMENTS[54025] = Fluid3D([6633,6625,7217,6265],0); -ELEMENTS[54026] = Fluid3D([6265,6032,6625,5929],0); -ELEMENTS[54027] = Fluid3D([6265,6032,5929,5894],0); -ELEMENTS[54028] = Fluid3D([6625,6032,7217,6585],0); -ELEMENTS[54029] = Fluid3D([6625,6032,6585,5829],0); -ELEMENTS[54030] = Fluid3D([6633,5894,6265,6313],0); -ELEMENTS[54031] = Fluid3D([6633,5894,6313,6694],0); -ELEMENTS[54032] = Fluid3D([6313,6633,6694,7027],0); -ELEMENTS[54033] = Fluid3D([6265,6633,6313,7154],0); -ELEMENTS[54034] = Fluid3D([5894,6265,6313,5854],0); -ELEMENTS[54035] = Fluid3D([6265,6313,5854,6448],0); -ELEMENTS[54036] = Fluid3D([5854,6265,6448,5929],0); -ELEMENTS[54037] = Fluid3D([5854,6265,5929,5512],0); -ELEMENTS[54038] = Fluid3D([6265,6448,5929,6419],0); -ELEMENTS[54039] = Fluid3D([5929,6265,6419,6625],0); -ELEMENTS[54040] = Fluid3D([6265,6419,6625,6791],0); -ELEMENTS[54041] = Fluid3D([6419,6625,6791,7258],0); -ELEMENTS[54042] = Fluid3D([6265,6419,6791,6448],0); -ELEMENTS[54043] = Fluid3D([6419,6791,6448,6764],0); -ELEMENTS[54044] = Fluid3D([6791,6448,6764,7154],0); -ELEMENTS[54045] = Fluid3D([6791,6448,7154,6265],0); -ELEMENTS[54046] = Fluid3D([6419,6791,6764,7258],0); -ELEMENTS[54047] = Fluid3D([6764,6791,7154,7258],0); -ELEMENTS[54048] = Fluid3D([6448,6419,6764,6568],0); -ELEMENTS[54049] = Fluid3D([6764,6448,6568,7154],0); -ELEMENTS[54050] = Fluid3D([6625,6265,6791,7154],0); -ELEMENTS[54051] = Fluid3D([6419,6764,6568,6944],0); -ELEMENTS[54052] = Fluid3D([6764,6568,6944,7154],0); -ELEMENTS[54053] = Fluid3D([6419,6764,6944,7258],0); -ELEMENTS[54054] = Fluid3D([6764,6944,7258,7154],0); -ELEMENTS[54055] = Fluid3D([6448,6568,7154,6828],0); -ELEMENTS[54056] = Fluid3D([6448,6568,6828,5864],0); -ELEMENTS[54057] = Fluid3D([7154,6448,6828,6580],0); -ELEMENTS[54058] = Fluid3D([7154,6448,6580,6313],0); -ELEMENTS[54059] = Fluid3D([6448,6828,6580,5864],0); -ELEMENTS[54060] = Fluid3D([6419,5929,6625,6387],0); -ELEMENTS[54061] = Fluid3D([6625,6419,6387,7258],0); -ELEMENTS[54062] = Fluid3D([6419,5929,6387,6362],0); -ELEMENTS[54063] = Fluid3D([6791,7154,7258,6625],0); -ELEMENTS[54064] = Fluid3D([6448,6580,6313,5854],0); -ELEMENTS[54065] = Fluid3D([6448,6419,6568,5929],0); -ELEMENTS[54066] = Fluid3D([6430,6633,7217,6694],0); -ELEMENTS[54067] = Fluid3D([6633,7217,6694,7027],0); -ELEMENTS[54068] = Fluid3D([6430,6633,6694,5894],0); -ELEMENTS[54069] = Fluid3D([6265,6313,6448,7154],0); -ELEMENTS[54070] = Fluid3D([6625,6032,5829,6387],0); -ELEMENTS[54071] = Fluid3D([6625,6032,6387,5929],0); -ELEMENTS[54072] = Fluid3D([5854,6265,5512,5894],0); -ELEMENTS[54073] = Fluid3D([18110,18201,18263,17971],0); -ELEMENTS[54074] = Fluid3D([18587,18493,18616,18574],0); -ELEMENTS[54075] = Fluid3D([7118,6740,6058,6518],0); -ELEMENTS[54076] = Fluid3D([7119,6509,6332,6181],0); -ELEMENTS[54077] = Fluid3D([6509,6332,6181,5754],0); -ELEMENTS[54078] = Fluid3D([6509,6332,5754,6302],0); -ELEMENTS[54079] = Fluid3D([14223,14240,14758,14818],0); -ELEMENTS[54080] = Fluid3D([7651,8053,8446,7308],0); -ELEMENTS[54081] = Fluid3D([7651,8053,7308,7290],0); -ELEMENTS[54082] = Fluid3D([7308,7651,7290,6794],0); -ELEMENTS[54083] = Fluid3D([7308,7651,6794,6812],0); -ELEMENTS[54084] = Fluid3D([7308,7651,6812,7606],0); -ELEMENTS[54085] = Fluid3D([7308,7651,7606,8446],0); -ELEMENTS[54086] = Fluid3D([7651,6794,6812,7505],0); -ELEMENTS[54087] = Fluid3D([7651,6812,7606,7991],0); -ELEMENTS[54088] = Fluid3D([7606,7651,7991,8446],0); -ELEMENTS[54089] = Fluid3D([6812,7308,7606,6750],0); -ELEMENTS[54090] = Fluid3D([7991,7606,8446,8084],0); -ELEMENTS[54091] = Fluid3D([7991,7606,8084,6968],0); -ELEMENTS[54092] = Fluid3D([7991,7606,6968,6812],0); -ELEMENTS[54093] = Fluid3D([7606,6968,6812,6750],0); -ELEMENTS[54094] = Fluid3D([5978,5798,5893,6661],0); -ELEMENTS[54095] = Fluid3D([15073,14541,14115,14661],0); -ELEMENTS[54096] = Fluid3D([8479,7817,8511,8458],0); -ELEMENTS[54097] = Fluid3D([7817,8511,8458,8552],0); -ELEMENTS[54098] = Fluid3D([8479,7817,8458,7820],0); -ELEMENTS[54099] = Fluid3D([17920,17739,17992,18027],0); -ELEMENTS[54100] = Fluid3D([18627,18631,18663,18665],0); -ELEMENTS[54101] = Fluid3D([18663,18627,18665,18679],0); -ELEMENTS[54102] = Fluid3D([18627,18665,18679,18638],0); -ELEMENTS[54103] = Fluid3D([18665,18679,18638,18659],0); -ELEMENTS[54104] = Fluid3D([18665,18663,18679,18683],0); -ELEMENTS[54105] = Fluid3D([18679,18665,18683,18687],0); -ELEMENTS[54106] = Fluid3D([18679,18665,18687,18659],0); -ELEMENTS[54107] = Fluid3D([18665,18663,18683,18687],0); -ELEMENTS[54108] = Fluid3D([18683,18679,18687,18696],0); -ELEMENTS[54109] = Fluid3D([18663,18679,18683,18648],0); -ELEMENTS[54110] = Fluid3D([18679,18683,18648,18692],0); -ELEMENTS[54111] = Fluid3D([18679,18683,18692,18696],0); -ELEMENTS[54112] = Fluid3D([18627,18631,18665,18586],0); -ELEMENTS[54113] = Fluid3D([17240,17361,17519,17198],0); -ELEMENTS[54114] = Fluid3D([17361,17519,17198,17681],0); -ELEMENTS[54115] = Fluid3D([17519,17198,17681,17461],0); -ELEMENTS[54116] = Fluid3D([14129,14243,13491,13962],0); -ELEMENTS[54117] = Fluid3D([8981,8178,8311,8189],0); -ELEMENTS[54118] = Fluid3D([15487,16019,16159,16313],0); -ELEMENTS[54119] = Fluid3D([16019,16159,16313,16624],0); -ELEMENTS[54120] = Fluid3D([11990,12628,13104,11993],0); -ELEMENTS[54121] = Fluid3D([11990,12628,11993,12143],0); -ELEMENTS[54122] = Fluid3D([10983,10270,11066,11390],0); -ELEMENTS[54123] = Fluid3D([6166,5640,6259,5887],0); -ELEMENTS[54124] = Fluid3D([3312,3526,3572,3183],0); -ELEMENTS[54125] = Fluid3D([3312,3526,3183,2969],0); -ELEMENTS[54126] = Fluid3D([3526,3572,3183,3594],0); -ELEMENTS[54127] = Fluid3D([16819,17149,17202,17072],0); -ELEMENTS[54128] = Fluid3D([11183,11111,11918,10840],0); -ELEMENTS[54129] = Fluid3D([11183,11111,10840,10135],0); -ELEMENTS[54130] = Fluid3D([11111,10840,10135,11091],0); -ELEMENTS[54131] = Fluid3D([11111,10840,11091,11918],0); -ELEMENTS[54132] = Fluid3D([10840,11091,11918,11230],0); -ELEMENTS[54133] = Fluid3D([10840,11091,11230,10321],0); -ELEMENTS[54134] = Fluid3D([11230,10840,10321,10352],0); -ELEMENTS[54135] = Fluid3D([11230,10840,10352,11183],0); -ELEMENTS[54136] = Fluid3D([10840,10321,10352,10135],0); -ELEMENTS[54137] = Fluid3D([10352,10840,10135,11183],0); -ELEMENTS[54138] = Fluid3D([10840,11091,10321,10135],0); -ELEMENTS[54139] = Fluid3D([11918,10840,11230,11183],0); -ELEMENTS[54140] = Fluid3D([10321,11230,10352,9908],0); -ELEMENTS[54141] = Fluid3D([11091,11230,10321,11397],0); -ELEMENTS[54142] = Fluid3D([12254,12333,12331,12732],0); -ELEMENTS[54143] = Fluid3D([8217,8820,7972,7629],0); -ELEMENTS[54144] = Fluid3D([5996,5779,5352,5316],0); -ELEMENTS[54145] = Fluid3D([5917,6396,6646,6748],0); -ELEMENTS[54146] = Fluid3D([10860,10801,11240,9919],0); -ELEMENTS[54147] = Fluid3D([17650,17836,17841,18088],0); -ELEMENTS[54148] = Fluid3D([7897,7973,7113,7223],0); -ELEMENTS[54149] = Fluid3D([7897,7973,7223,8103],0); -ELEMENTS[54150] = Fluid3D([2450,2496,2742,2340],0); -ELEMENTS[54151] = Fluid3D([10668,10277,10249,11509],0); -ELEMENTS[54152] = Fluid3D([17331,16921,16792,17293],0); -ELEMENTS[54153] = Fluid3D([12099,10984,11438,11726],0); -ELEMENTS[54154] = Fluid3D([7618,7556,6664,7448],0); -ELEMENTS[54155] = Fluid3D([7618,7556,7448,8250],0); -ELEMENTS[54156] = Fluid3D([7556,6664,7448,7329],0); -ELEMENTS[54157] = Fluid3D([5515,5897,5986,6366],0); -ELEMENTS[54158] = Fluid3D([17731,17433,17671,17432],0); -ELEMENTS[54159] = Fluid3D([17731,17433,17432,17236],0); -ELEMENTS[54160] = Fluid3D([7467,6885,6772,7981],0); -ELEMENTS[54161] = Fluid3D([7120,7234,7929,7895],0); -ELEMENTS[54162] = Fluid3D([18237,18348,18409,18448],0); -ELEMENTS[54163] = Fluid3D([6968,6277,6812,6750],0); -ELEMENTS[54164] = Fluid3D([14910,14289,14961,14904],0); -ELEMENTS[54165] = Fluid3D([5469,5086,4892,5190],0); -ELEMENTS[54166] = Fluid3D([5086,4892,5190,4635],0); -ELEMENTS[54167] = Fluid3D([5086,4892,4635,4357],0); -ELEMENTS[54168] = Fluid3D([5190,5086,4635,5452],0); -ELEMENTS[54169] = Fluid3D([5190,5086,5452,5469],0); -ELEMENTS[54170] = Fluid3D([4853,5084,4471,4489],0); -ELEMENTS[54171] = Fluid3D([15132,14864,15447,15059],0); -ELEMENTS[54172] = Fluid3D([2454,2524,2844,2734],0); -ELEMENTS[54173] = Fluid3D([2454,2524,2734,2439],0); -ELEMENTS[54174] = Fluid3D([12951,12778,12692,13208],0); -ELEMENTS[54175] = Fluid3D([12951,12778,13208,13372],0); -ELEMENTS[54176] = Fluid3D([12778,12692,13208,11858],0); -ELEMENTS[54177] = Fluid3D([13208,12778,11858,12691],0); -ELEMENTS[54178] = Fluid3D([13208,12778,12691,13213],0); -ELEMENTS[54179] = Fluid3D([13208,12778,13213,13372],0); -ELEMENTS[54180] = Fluid3D([12778,12691,13213,12512],0); -ELEMENTS[54181] = Fluid3D([12778,12691,12512,11858],0); -ELEMENTS[54182] = Fluid3D([13213,12778,12512,12440],0); -ELEMENTS[54183] = Fluid3D([12778,12512,12440,11858],0); -ELEMENTS[54184] = Fluid3D([12691,13213,12512,12856],0); -ELEMENTS[54185] = Fluid3D([13213,12512,12856,12440],0); -ELEMENTS[54186] = Fluid3D([12512,12856,12440,11880],0); -ELEMENTS[54187] = Fluid3D([12440,12512,11880,11858],0); -ELEMENTS[54188] = Fluid3D([12512,12856,11880,11914],0); -ELEMENTS[54189] = Fluid3D([12691,13208,13213,13725],0); -ELEMENTS[54190] = Fluid3D([13208,13213,13725,13843],0); -ELEMENTS[54191] = Fluid3D([13213,13725,13843,13458],0); -ELEMENTS[54192] = Fluid3D([13213,12691,13725,13458],0); -ELEMENTS[54193] = Fluid3D([12512,12691,12856,11914],0); -ELEMENTS[54194] = Fluid3D([13213,12778,12440,13372],0); -ELEMENTS[54195] = Fluid3D([13224,13986,13270,13358],0); -ELEMENTS[54196] = Fluid3D([10907,11217,10424,11385],0); -ELEMENTS[54197] = Fluid3D([5070,4927,5520,5625],0); -ELEMENTS[54198] = Fluid3D([2134,2222,2092,2009],0); -ELEMENTS[54199] = Fluid3D([2134,2222,2009,2214],0); -ELEMENTS[54200] = Fluid3D([2222,2092,2009,2037],0); -ELEMENTS[54201] = Fluid3D([2092,2134,2009,1924],0); -ELEMENTS[54202] = Fluid3D([2134,2009,1924,1911],0); -ELEMENTS[54203] = Fluid3D([2009,2092,1924,1809],0); -ELEMENTS[54204] = Fluid3D([8387,7514,7935,8778],0); -ELEMENTS[54205] = Fluid3D([10919,10923,9780,10845],0); -ELEMENTS[54206] = Fluid3D([10919,10923,10845,11958],0); -ELEMENTS[54207] = Fluid3D([2267,2233,2182,2493],0); -ELEMENTS[54208] = Fluid3D([17076,16923,16870,16596],0); -ELEMENTS[54209] = Fluid3D([17076,16923,16596,16490],0); -ELEMENTS[54210] = Fluid3D([12688,11652,12672,12531],0); -ELEMENTS[54211] = Fluid3D([12815,12044,12148,12875],0); -ELEMENTS[54212] = Fluid3D([10208,10349,11223,11289],0); -ELEMENTS[54213] = Fluid3D([11223,10208,11289,11022],0); -ELEMENTS[54214] = Fluid3D([1862,1870,1739,1836],0); -ELEMENTS[54215] = Fluid3D([6019,5569,6145,6385],0); -ELEMENTS[54216] = Fluid3D([4475,4135,3905,4319],0); -ELEMENTS[54217] = Fluid3D([4475,4135,4319,4740],0); -ELEMENTS[54218] = Fluid3D([3905,4475,4319,4237],0); -ELEMENTS[54219] = Fluid3D([4475,4135,4740,4692],0); -ELEMENTS[54220] = Fluid3D([4319,4475,4740,4879],0); -ELEMENTS[54221] = Fluid3D([4319,4475,4879,4723],0); -ELEMENTS[54222] = Fluid3D([6766,6292,6131,6052],0); -ELEMENTS[54223] = Fluid3D([12569,12141,11950,12056],0); -ELEMENTS[54224] = Fluid3D([11950,12569,12056,12061],0); -ELEMENTS[54225] = Fluid3D([14992,14371,14296,14072],0); -ELEMENTS[54226] = Fluid3D([5745,6360,6160,5744],0); -ELEMENTS[54227] = Fluid3D([15642,15334,15257,15423],0); -ELEMENTS[54228] = Fluid3D([15642,15334,15423,16153],0); -ELEMENTS[54229] = Fluid3D([15257,15642,15423,15714],0); -ELEMENTS[54230] = Fluid3D([4141,3786,3776,3581],0); -ELEMENTS[54231] = Fluid3D([4325,4487,4825,4944],0); -ELEMENTS[54232] = Fluid3D([3429,3533,3375,3075],0); -ELEMENTS[54233] = Fluid3D([3429,3533,3075,3142],0); -ELEMENTS[54234] = Fluid3D([5607,5216,5823,5444],0); -ELEMENTS[54235] = Fluid3D([5607,5216,5444,4885],0); -ELEMENTS[54236] = Fluid3D([8056,8076,8341,7520],0); -ELEMENTS[54237] = Fluid3D([8056,8076,7520,7079],0); -ELEMENTS[54238] = Fluid3D([8076,7520,7079,7188],0); -ELEMENTS[54239] = Fluid3D([8056,8076,7079,7803],0); -ELEMENTS[54240] = Fluid3D([12206,11745,12069,12676],0); -ELEMENTS[54241] = Fluid3D([7163,7724,7814,6444],0); -ELEMENTS[54242] = Fluid3D([15389,15755,16181,15799],0); -ELEMENTS[54243] = Fluid3D([15846,15299,15480,16042],0); -ELEMENTS[54244] = Fluid3D([2654,2701,2980,2706],0); -ELEMENTS[54245] = Fluid3D([2654,2701,2706,2427],0); -ELEMENTS[54246] = Fluid3D([2980,2654,2706,2547],0); -ELEMENTS[54247] = Fluid3D([2706,2654,2427,2547],0); -ELEMENTS[54248] = Fluid3D([10496,9714,10806,9853],0); -ELEMENTS[54249] = Fluid3D([14986,15123,15481,14778],0); -ELEMENTS[54250] = Fluid3D([15123,15481,14778,15194],0); -ELEMENTS[54251] = Fluid3D([15481,14986,14778,15096],0); -ELEMENTS[54252] = Fluid3D([14778,15481,15096,15619],0); -ELEMENTS[54253] = Fluid3D([14986,14778,15096,14258],0); -ELEMENTS[54254] = Fluid3D([14986,14778,14258,15123],0); -ELEMENTS[54255] = Fluid3D([15481,14986,15096,15844],0); -ELEMENTS[54256] = Fluid3D([15096,15481,15844,15619],0); -ELEMENTS[54257] = Fluid3D([14778,15096,14258,14622],0); -ELEMENTS[54258] = Fluid3D([2667,2957,2511,2738],0); -ELEMENTS[54259] = Fluid3D([3179,3404,3333,3794],0); -ELEMENTS[54260] = Fluid3D([7943,8322,8619,9215],0); -ELEMENTS[54261] = Fluid3D([15979,16229,16141,16710],0); -ELEMENTS[54262] = Fluid3D([3875,3945,4361,4350],0); -ELEMENTS[54263] = Fluid3D([17295,17346,17386,16932],0); -ELEMENTS[54264] = Fluid3D([5031,4650,5524,5118],0); -ELEMENTS[54265] = Fluid3D([5031,4650,5118,4850],0); -ELEMENTS[54266] = Fluid3D([5524,5031,5118,5530],0); -ELEMENTS[54267] = Fluid3D([13839,13907,14578,14301],0); -ELEMENTS[54268] = Fluid3D([17369,17036,17067,16961],0); -ELEMENTS[54269] = Fluid3D([6724,6106,6142,7079],0); -ELEMENTS[54270] = Fluid3D([13081,13763,13555,13957],0); -ELEMENTS[54271] = Fluid3D([9924,10043,10746,10957],0); -ELEMENTS[54272] = Fluid3D([9924,10043,10957,10612],0); -ELEMENTS[54273] = Fluid3D([10746,9924,10957,10384],0); -ELEMENTS[54274] = Fluid3D([5428,5364,5922,5657],0); -ELEMENTS[54275] = Fluid3D([5364,5922,5657,5299],0); -ELEMENTS[54276] = Fluid3D([17103,16928,17204,17378],0); -ELEMENTS[54277] = Fluid3D([18642,18593,18659,18586],0); -ELEMENTS[54278] = Fluid3D([18642,18593,18586,18590],0); -ELEMENTS[54279] = Fluid3D([18586,18642,18590,18631],0); -ELEMENTS[54280] = Fluid3D([18642,18590,18631,18667],0); -ELEMENTS[54281] = Fluid3D([18631,18642,18667,18665],0); -ELEMENTS[54282] = Fluid3D([18586,18642,18631,18665],0); -ELEMENTS[54283] = Fluid3D([18590,18586,18631,18501],0); -ELEMENTS[54284] = Fluid3D([18593,18586,18590,18478],0); -ELEMENTS[54285] = Fluid3D([18590,18631,18667,18633],0); -ELEMENTS[54286] = Fluid3D([18631,18667,18633,18635],0); -ELEMENTS[54287] = Fluid3D([18631,18667,18635,18663],0); -ELEMENTS[54288] = Fluid3D([18667,18631,18665,18663],0); -ELEMENTS[54289] = Fluid3D([18593,18659,18586,18638],0); -ELEMENTS[54290] = Fluid3D([15824,15730,15346,15054],0); -ELEMENTS[54291] = Fluid3D([17082,16905,17297,17289],0); -ELEMENTS[54292] = Fluid3D([7367,6757,6601,6710],0); -ELEMENTS[54293] = Fluid3D([6601,7367,6710,6965],0); -ELEMENTS[54294] = Fluid3D([7367,6710,6965,7341],0); -ELEMENTS[54295] = Fluid3D([6710,6965,7341,6456],0); -ELEMENTS[54296] = Fluid3D([6601,7367,6965,7478],0); -ELEMENTS[54297] = Fluid3D([6965,7341,6456,6891],0); -ELEMENTS[54298] = Fluid3D([6965,7341,6891,7513],0); -ELEMENTS[54299] = Fluid3D([6965,7341,7513,7367],0); -ELEMENTS[54300] = Fluid3D([7341,6891,7513,7117],0); -ELEMENTS[54301] = Fluid3D([6891,6965,7513,7050],0); -ELEMENTS[54302] = Fluid3D([6965,7513,7050,7478],0); -ELEMENTS[54303] = Fluid3D([7341,6456,6891,7117],0); -ELEMENTS[54304] = Fluid3D([7513,6891,7050,7604],0); -ELEMENTS[54305] = Fluid3D([7050,7513,7604,7478],0); -ELEMENTS[54306] = Fluid3D([6891,6965,7050,6091],0); -ELEMENTS[54307] = Fluid3D([6710,6601,6965,6090],0); -ELEMENTS[54308] = Fluid3D([6891,7050,7604,6536],0); -ELEMENTS[54309] = Fluid3D([6456,6891,7117,6091],0); -ELEMENTS[54310] = Fluid3D([12919,13378,12445,12903],0); -ELEMENTS[54311] = Fluid3D([14650,15356,15103,14932],0); -ELEMENTS[54312] = Fluid3D([18426,18278,18415,18437],0); -ELEMENTS[54313] = Fluid3D([15907,16063,15522,15826],0); -ELEMENTS[54314] = Fluid3D([7588,7934,7225,7818],0); -ELEMENTS[54315] = Fluid3D([18516,18371,18535,18478],0); -ELEMENTS[54316] = Fluid3D([7112,6964,6532,7079],0); -ELEMENTS[54317] = Fluid3D([13332,12552,12233,12373],0); -ELEMENTS[54318] = Fluid3D([1807,1808,1727,1729],0); -ELEMENTS[54319] = Fluid3D([1807,1808,1729,1849],0); -ELEMENTS[54320] = Fluid3D([1808,1727,1729,1639],0); -ELEMENTS[54321] = Fluid3D([6519,7190,6120,6404],0); -ELEMENTS[54322] = Fluid3D([7190,6120,6404,6768],0); -ELEMENTS[54323] = Fluid3D([6120,6519,6404,6000],0); -ELEMENTS[54324] = Fluid3D([6519,7190,6404,7078],0); -ELEMENTS[54325] = Fluid3D([6519,6404,6000,7078],0); -ELEMENTS[54326] = Fluid3D([6404,6120,6000,5858],0); -ELEMENTS[54327] = Fluid3D([6404,6120,5858,6768],0); -ELEMENTS[54328] = Fluid3D([6000,6404,5858,5748],0); -ELEMENTS[54329] = Fluid3D([5858,6000,5748,5197],0); -ELEMENTS[54330] = Fluid3D([5748,5858,5197,5106],0); -ELEMENTS[54331] = Fluid3D([6404,5858,5748,6351],0); -ELEMENTS[54332] = Fluid3D([6404,5858,6351,6768],0); -ELEMENTS[54333] = Fluid3D([5858,5748,6351,5455],0); -ELEMENTS[54334] = Fluid3D([17714,17446,17703,17710],0); -ELEMENTS[54335] = Fluid3D([3494,3522,3926,3505],0); -ELEMENTS[54336] = Fluid3D([15174,15592,15261,15305],0); -ELEMENTS[54337] = Fluid3D([6630,6490,7223,7113],0); -ELEMENTS[54338] = Fluid3D([14380,14282,15059,14333],0); -ELEMENTS[54339] = Fluid3D([14380,14282,14333,13329],0); -ELEMENTS[54340] = Fluid3D([14282,15059,14333,14669],0); -ELEMENTS[54341] = Fluid3D([14333,14282,14669,13781],0); -ELEMENTS[54342] = Fluid3D([14669,14333,13781,14853],0); -ELEMENTS[54343] = Fluid3D([15059,14333,14669,15406],0); -ELEMENTS[54344] = Fluid3D([3751,3971,4047,3537],0); -ELEMENTS[54345] = Fluid3D([12973,12547,13491,13400],0); -ELEMENTS[54346] = Fluid3D([11807,11399,11441,10540],0); -ELEMENTS[54347] = Fluid3D([8534,8055,7970,7520],0); -ELEMENTS[54348] = Fluid3D([6650,6540,6254,5975],0); -ELEMENTS[54349] = Fluid3D([6650,6540,5975,5802],0); -ELEMENTS[54350] = Fluid3D([6254,6650,5975,7104],0); -ELEMENTS[54351] = Fluid3D([14248,13894,13369,14498],0); -ELEMENTS[54352] = Fluid3D([4420,4381,3900,4162],0); -ELEMENTS[54353] = Fluid3D([4420,4381,4162,4664],0); -ELEMENTS[54354] = Fluid3D([3900,4420,4162,4248],0); -ELEMENTS[54355] = Fluid3D([4420,4162,4248,4487],0); -ELEMENTS[54356] = Fluid3D([3900,4420,4248,4528],0); -ELEMENTS[54357] = Fluid3D([4420,4248,4528,4944],0); -ELEMENTS[54358] = Fluid3D([8053,8773,7954,8591],0); -ELEMENTS[54359] = Fluid3D([17750,17779,17536,17845],0); -ELEMENTS[54360] = Fluid3D([17375,17028,16897,17301],0); -ELEMENTS[54361] = Fluid3D([17821,17564,17477,17575],0); -ELEMENTS[54362] = Fluid3D([14987,14710,15434,15274],0); -ELEMENTS[54363] = Fluid3D([14987,14710,15274,14847],0); -ELEMENTS[54364] = Fluid3D([15523,15035,15024,15321],0); -ELEMENTS[54365] = Fluid3D([15035,15024,15321,14933],0); -ELEMENTS[54366] = Fluid3D([15024,15321,14933,15877],0); -ELEMENTS[54367] = Fluid3D([15024,15321,15877,15523],0); -ELEMENTS[54368] = Fluid3D([9802,10056,9735,10514],0); -ELEMENTS[54369] = Fluid3D([17246,16835,17230,17234],0); -ELEMENTS[54370] = Fluid3D([12833,13094,12194,13204],0); -ELEMENTS[54371] = Fluid3D([14343,14125,14149,13660],0); -ELEMENTS[54372] = Fluid3D([12940,12809,12714,13783],0); -ELEMENTS[54373] = Fluid3D([15861,15602,15482,15202],0); -ELEMENTS[54374] = Fluid3D([15602,15482,15202,15179],0); -ELEMENTS[54375] = Fluid3D([15202,15602,15179,14870],0); -ELEMENTS[54376] = Fluid3D([15861,15602,15202,15573],0); -ELEMENTS[54377] = Fluid3D([15482,15861,15202,15071],0); -ELEMENTS[54378] = Fluid3D([15202,15482,15071,14789],0); -ELEMENTS[54379] = Fluid3D([15202,15602,14870,14907],0); -ELEMENTS[54380] = Fluid3D([15202,15602,14907,15573],0); -ELEMENTS[54381] = Fluid3D([15482,15202,15179,14789],0); -ELEMENTS[54382] = Fluid3D([14870,15202,14907,14467],0); -ELEMENTS[54383] = Fluid3D([15401,15834,15291,15163],0); -ELEMENTS[54384] = Fluid3D([15291,15401,15163,14470],0); -ELEMENTS[54385] = Fluid3D([15291,15401,14470,14530],0); -ELEMENTS[54386] = Fluid3D([18151,18017,17945,17894],0); -ELEMENTS[54387] = Fluid3D([18151,18017,17894,18193],0); -ELEMENTS[54388] = Fluid3D([14809,15315,15692,15018],0); -ELEMENTS[54389] = Fluid3D([7621,7034,7189,6821],0); -ELEMENTS[54390] = Fluid3D([7579,8224,7511,7597],0); -ELEMENTS[54391] = Fluid3D([15725,15666,16072,16165],0); -ELEMENTS[54392] = Fluid3D([16072,15725,16165,16376],0); -ELEMENTS[54393] = Fluid3D([16165,16072,16376,16536],0); -ELEMENTS[54394] = Fluid3D([16072,16376,16536,16730],0); -ELEMENTS[54395] = Fluid3D([16165,16072,16536,16353],0); -ELEMENTS[54396] = Fluid3D([4436,4830,4352,4384],0); -ELEMENTS[54397] = Fluid3D([12354,12674,12658,12246],0); -ELEMENTS[54398] = Fluid3D([16528,17008,16544,16968],0); -ELEMENTS[54399] = Fluid3D([8466,9046,8871,8304],0); -ELEMENTS[54400] = Fluid3D([13738,13525,12831,13402],0); -ELEMENTS[54401] = Fluid3D([6196,5626,5757,5888],0); -ELEMENTS[54402] = Fluid3D([8027,8674,8570,8875],0); -ELEMENTS[54403] = Fluid3D([10669,9836,9720,10661],0); -ELEMENTS[54404] = Fluid3D([9720,10669,10661,10795],0); -ELEMENTS[54405] = Fluid3D([10669,10661,10795,11960],0); -ELEMENTS[54406] = Fluid3D([12431,12567,11743,12095],0); -ELEMENTS[54407] = Fluid3D([12567,11743,12095,12727],0); -ELEMENTS[54408] = Fluid3D([12567,11743,12727,13073],0); -ELEMENTS[54409] = Fluid3D([3966,3961,4437,3995],0); -ELEMENTS[54410] = Fluid3D([7401,7681,7034,6997],0); -ELEMENTS[54411] = Fluid3D([10718,10603,11589,11269],0); -ELEMENTS[54412] = Fluid3D([11589,10718,11269,12170],0); -ELEMENTS[54413] = Fluid3D([5958,6097,5475,5994],0); -ELEMENTS[54414] = Fluid3D([6097,5475,5994,5858],0); -ELEMENTS[54415] = Fluid3D([8373,8257,8294,7754],0); -ELEMENTS[54416] = Fluid3D([15075,15022,14469,15346],0); -ELEMENTS[54417] = Fluid3D([15223,15219,15850,15946],0); -ELEMENTS[54418] = Fluid3D([18209,18187,18339,18108],0); -ELEMENTS[54419] = Fluid3D([10714,10446,11183,11016],0); -ELEMENTS[54420] = Fluid3D([5403,5466,5205,6111],0); -ELEMENTS[54421] = Fluid3D([8342,7803,8756,8483],0); -ELEMENTS[54422] = Fluid3D([7952,7426,8272,8367],0); -ELEMENTS[54423] = Fluid3D([14707,14953,14642,15396],0); -ELEMENTS[54424] = Fluid3D([9080,8956,9884,9829],0); -ELEMENTS[54425] = Fluid3D([10447,10186,10488,11277],0); -ELEMENTS[54426] = Fluid3D([13832,14453,14735,14417],0); -ELEMENTS[54427] = Fluid3D([14453,14735,14417,15246],0); -ELEMENTS[54428] = Fluid3D([8297,7994,8829,8708],0); -ELEMENTS[54429] = Fluid3D([14354,14401,13888,13315],0); -ELEMENTS[54430] = Fluid3D([15953,16002,16405,16623],0); -ELEMENTS[54431] = Fluid3D([8858,8507,8614,7745],0); -ELEMENTS[54432] = Fluid3D([8507,8614,7745,7856],0); -ELEMENTS[54433] = Fluid3D([18570,18587,18607,18504],0); -ELEMENTS[54434] = Fluid3D([16308,15812,15800,16169],0); -ELEMENTS[54435] = Fluid3D([14751,14513,13809,14268],0); -ELEMENTS[54436] = Fluid3D([13809,14751,14268,14231],0); -ELEMENTS[54437] = Fluid3D([14751,14513,14268,15084],0); -ELEMENTS[54438] = Fluid3D([14268,14751,15084,14906],0); -ELEMENTS[54439] = Fluid3D([14751,14513,15084,15283],0); -ELEMENTS[54440] = Fluid3D([6349,6253,5755,6352],0); -ELEMENTS[54441] = Fluid3D([9723,9385,9177,10157],0); -ELEMENTS[54442] = Fluid3D([10393,10248,10516,9437],0); -ELEMENTS[54443] = Fluid3D([17099,17309,17528,17228],0); -ELEMENTS[54444] = Fluid3D([11097,11458,10887,11966],0); -ELEMENTS[54445] = Fluid3D([12463,13094,12194,12300],0); -ELEMENTS[54446] = Fluid3D([8450,7870,7641,7717],0); -ELEMENTS[54447] = Fluid3D([13581,13649,12732,12967],0); -ELEMENTS[54448] = Fluid3D([5485,5821,6048,6130],0); -ELEMENTS[54449] = Fluid3D([17877,17744,17988,18052],0); -ELEMENTS[54450] = Fluid3D([4221,4183,3893,4701],0); -ELEMENTS[54451] = Fluid3D([10056,10288,9936,10850],0); -ELEMENTS[54452] = Fluid3D([10288,9936,10850,10181],0); -ELEMENTS[54453] = Fluid3D([10056,10288,10850,11212],0); -ELEMENTS[54454] = Fluid3D([14747,14510,13825,14640],0); -ELEMENTS[54455] = Fluid3D([14747,14510,14640,15219],0); -ELEMENTS[54456] = Fluid3D([6433,6413,6168,7026],0); -ELEMENTS[54457] = Fluid3D([12516,13233,13426,13133],0); -ELEMENTS[54458] = Fluid3D([12516,13233,13133,12219],0); -ELEMENTS[54459] = Fluid3D([16079,15866,16472,16325],0); -ELEMENTS[54460] = Fluid3D([16079,15866,16325,15724],0); -ELEMENTS[54461] = Fluid3D([16325,16079,15724,16117],0); -ELEMENTS[54462] = Fluid3D([16079,15866,15724,15314],0); -ELEMENTS[54463] = Fluid3D([16325,16079,16117,16800],0); -ELEMENTS[54464] = Fluid3D([16079,15724,16117,15314],0); -ELEMENTS[54465] = Fluid3D([16472,16079,16325,16800],0); -ELEMENTS[54466] = Fluid3D([15866,16325,15724,15728],0); -ELEMENTS[54467] = Fluid3D([15724,15866,15728,15222],0); -ELEMENTS[54468] = Fluid3D([16325,15724,15728,16121],0); -ELEMENTS[54469] = Fluid3D([15866,15724,15314,15222],0); -ELEMENTS[54470] = Fluid3D([15866,16472,16325,16149],0); -ELEMENTS[54471] = Fluid3D([15724,16325,16117,16121],0); -ELEMENTS[54472] = Fluid3D([15724,15314,15222,14881],0); -ELEMENTS[54473] = Fluid3D([13059,13363,12156,12594],0); -ELEMENTS[54474] = Fluid3D([14810,15512,14936,15206],0); -ELEMENTS[54475] = Fluid3D([11387,11386,12020,12675],0); -ELEMENTS[54476] = Fluid3D([18214,18146,18373,18078],0); -ELEMENTS[54477] = Fluid3D([9263,8621,8676,8249],0); -ELEMENTS[54478] = Fluid3D([8621,8676,8249,8073],0); -ELEMENTS[54479] = Fluid3D([9263,8621,8249,8451],0); -ELEMENTS[54480] = Fluid3D([8621,8249,8451,8194],0); -ELEMENTS[54481] = Fluid3D([8451,8621,8194,9102],0); -ELEMENTS[54482] = Fluid3D([8621,8249,8194,7461],0); -ELEMENTS[54483] = Fluid3D([9263,8621,8451,9102],0); -ELEMENTS[54484] = Fluid3D([8676,9263,8249,8647],0); -ELEMENTS[54485] = Fluid3D([8249,8451,8194,7757],0); -ELEMENTS[54486] = Fluid3D([8451,8194,7757,9102],0); -ELEMENTS[54487] = Fluid3D([8249,8451,7757,7761],0); -ELEMENTS[54488] = Fluid3D([8451,7757,7761,8193],0); -ELEMENTS[54489] = Fluid3D([8451,7757,8193,9102],0); -ELEMENTS[54490] = Fluid3D([8193,8451,9102,8647],0); -ELEMENTS[54491] = Fluid3D([8193,8451,8647,7761],0); -ELEMENTS[54492] = Fluid3D([7757,7761,8193,7244],0); -ELEMENTS[54493] = Fluid3D([8193,7757,7244,7447],0); -ELEMENTS[54494] = Fluid3D([7757,7761,7244,6911],0); -ELEMENTS[54495] = Fluid3D([8621,8249,7461,8073],0); -ELEMENTS[54496] = Fluid3D([8249,8451,7761,8647],0); -ELEMENTS[54497] = Fluid3D([8249,9263,8451,8647],0); -ELEMENTS[54498] = Fluid3D([9263,8451,8647,9102],0); -ELEMENTS[54499] = Fluid3D([7757,8249,7761,7461],0); -ELEMENTS[54500] = Fluid3D([10392,11378,11281,10674],0); -ELEMENTS[54501] = Fluid3D([6198,6200,6657,5648],0); -ELEMENTS[54502] = Fluid3D([6198,6200,5648,5442],0); -ELEMENTS[54503] = Fluid3D([4991,4507,4758,4263],0); -ELEMENTS[54504] = Fluid3D([14355,14206,13959,14678],0); -ELEMENTS[54505] = Fluid3D([14206,13959,14678,13530],0); -ELEMENTS[54506] = Fluid3D([11481,11629,10621,11762],0); -ELEMENTS[54507] = Fluid3D([17933,17653,17592,17701],0); -ELEMENTS[54508] = Fluid3D([12720,12927,12714,12057],0); -ELEMENTS[54509] = Fluid3D([12720,12927,12057,13225],0); -ELEMENTS[54510] = Fluid3D([12714,12720,12057,12016],0); -ELEMENTS[54511] = Fluid3D([11907,11981,11797,12887],0); -ELEMENTS[54512] = Fluid3D([2722,2865,3157,2885],0); -ELEMENTS[54513] = Fluid3D([2722,2865,2885,2783],0); -ELEMENTS[54514] = Fluid3D([15555,15587,15609,16137],0); -ELEMENTS[54515] = Fluid3D([3074,2912,2828,2577],0); -ELEMENTS[54516] = Fluid3D([7787,7237,6854,6836],0); -ELEMENTS[54517] = Fluid3D([17076,16882,16490,16876],0); -ELEMENTS[54518] = Fluid3D([16882,16490,16876,16350],0); -ELEMENTS[54519] = Fluid3D([13889,13443,13114,13124],0); -ELEMENTS[54520] = Fluid3D([16304,15758,16531,16411],0); -ELEMENTS[54521] = Fluid3D([16531,16304,16411,16775],0); -ELEMENTS[54522] = Fluid3D([16435,16924,16658,16162],0); -ELEMENTS[54523] = Fluid3D([16658,16435,16162,16831],0); -ELEMENTS[54524] = Fluid3D([4733,4194,4907,4288],0); -ELEMENTS[54525] = Fluid3D([4733,4194,4288,4339],0); -ELEMENTS[54526] = Fluid3D([4194,4288,4339,3922],0); -ELEMENTS[54527] = Fluid3D([4339,4194,3922,4404],0); -ELEMENTS[54528] = Fluid3D([4194,4288,3922,3781],0); -ELEMENTS[54529] = Fluid3D([4194,4288,3781,4207],0); -ELEMENTS[54530] = Fluid3D([3922,4194,3781,3610],0); -ELEMENTS[54531] = Fluid3D([3781,4194,4207,3716],0); -ELEMENTS[54532] = Fluid3D([4194,4288,4207,4907],0); -ELEMENTS[54533] = Fluid3D([4194,3922,4404,3946],0); -ELEMENTS[54534] = Fluid3D([4194,3922,3946,3610],0); -ELEMENTS[54535] = Fluid3D([4404,4194,3946,4031],0); -ELEMENTS[54536] = Fluid3D([4288,4733,4339,4992],0); -ELEMENTS[54537] = Fluid3D([3922,3946,3610,3869],0); -ELEMENTS[54538] = Fluid3D([3946,3610,3869,3912],0); -ELEMENTS[54539] = Fluid3D([3869,3946,3912,4507],0); -ELEMENTS[54540] = Fluid3D([3946,3610,3912,4031],0); -ELEMENTS[54541] = Fluid3D([3946,3610,4031,3716],0); -ELEMENTS[54542] = Fluid3D([3610,3869,3912,3508],0); -ELEMENTS[54543] = Fluid3D([3869,3912,3508,3825],0); -ELEMENTS[54544] = Fluid3D([3912,3946,4031,4376],0); -ELEMENTS[54545] = Fluid3D([3610,3869,3508,3922],0); -ELEMENTS[54546] = Fluid3D([3946,3610,3716,4194],0); -ELEMENTS[54547] = Fluid3D([3922,3946,3869,4404],0); -ELEMENTS[54548] = Fluid3D([3869,3912,3825,4170],0); -ELEMENTS[54549] = Fluid3D([3869,3912,4170,4507],0); -ELEMENTS[54550] = Fluid3D([4170,3869,4507,4375],0); -ELEMENTS[54551] = Fluid3D([4031,3946,3716,4194],0); -ELEMENTS[54552] = Fluid3D([3508,3869,3825,3878],0); -ELEMENTS[54553] = Fluid3D([3825,3869,4170,3878],0); -ELEMENTS[54554] = Fluid3D([3869,4170,3878,4375],0); -ELEMENTS[54555] = Fluid3D([4507,4170,4375,4792],0); -ELEMENTS[54556] = Fluid3D([4507,4170,4792,4758],0); -ELEMENTS[54557] = Fluid3D([3508,3869,3878,3922],0); -ELEMENTS[54558] = Fluid3D([5300,5555,5436,5842],0); -ELEMENTS[54559] = Fluid3D([5300,5555,5842,5704],0); -ELEMENTS[54560] = Fluid3D([5552,6109,5944,6042],0); -ELEMENTS[54561] = Fluid3D([4478,4251,4033,4080],0); -ELEMENTS[54562] = Fluid3D([4251,4033,4080,3679],0); -ELEMENTS[54563] = Fluid3D([16631,16487,17104,16968],0); -ELEMENTS[54564] = Fluid3D([5047,5419,5143,5479],0); -ELEMENTS[54565] = Fluid3D([7512,7024,6438,7416],0); -ELEMENTS[54566] = Fluid3D([17003,17353,17204,16810],0); -ELEMENTS[54567] = Fluid3D([17003,17353,16810,17423],0); -ELEMENTS[54568] = Fluid3D([3043,2670,2854,2705],0); -ELEMENTS[54569] = Fluid3D([3551,3616,3802,3128],0); -ELEMENTS[54570] = Fluid3D([12662,11689,12207,12629],0); -ELEMENTS[54571] = Fluid3D([9149,9708,10057,9132],0); -ELEMENTS[54572] = Fluid3D([15500,15640,15181,15037],0); -ELEMENTS[54573] = Fluid3D([15500,15640,15037,15548],0); -ELEMENTS[54574] = Fluid3D([15037,15500,15548,15772],0); -ELEMENTS[54575] = Fluid3D([15037,15500,15772,15408],0); -ELEMENTS[54576] = Fluid3D([15037,15500,15408,14694],0); -ELEMENTS[54577] = Fluid3D([15037,15500,14694,14727],0); -ELEMENTS[54578] = Fluid3D([15037,15500,14727,15181],0); -ELEMENTS[54579] = Fluid3D([15500,14727,15181,15793],0); -ELEMENTS[54580] = Fluid3D([13598,12980,12750,12928],0); -ELEMENTS[54581] = Fluid3D([12980,12750,12928,12154],0); -ELEMENTS[54582] = Fluid3D([12928,12980,12154,12303],0); -ELEMENTS[54583] = Fluid3D([10824,11723,11791,11401],0); -ELEMENTS[54584] = Fluid3D([9110,10104,9374,9477],0); -ELEMENTS[54585] = Fluid3D([9374,9110,9477,8306],0); -ELEMENTS[54586] = Fluid3D([9209,8768,9030,9734],0); -ELEMENTS[54587] = Fluid3D([3198,3335,2851,3135],0); -ELEMENTS[54588] = Fluid3D([3198,3335,3135,3437],0); -ELEMENTS[54589] = Fluid3D([9270,10212,10062,9656],0); -ELEMENTS[54590] = Fluid3D([8406,8699,7966,7351],0); -ELEMENTS[54591] = Fluid3D([14558,13789,14027,14323],0); -ELEMENTS[54592] = Fluid3D([4208,4393,4825,4886],0); -ELEMENTS[54593] = Fluid3D([15771,16332,16463,16183],0); -ELEMENTS[54594] = Fluid3D([15771,16332,16183,16218],0); -ELEMENTS[54595] = Fluid3D([16332,16463,16183,16803],0); -ELEMENTS[54596] = Fluid3D([16332,16183,16218,16803],0); -ELEMENTS[54597] = Fluid3D([16332,16463,16803,16578],0); -ELEMENTS[54598] = Fluid3D([8210,8209,7403,7621],0); -ELEMENTS[54599] = Fluid3D([3989,4103,3745,4000],0); -ELEMENTS[54600] = Fluid3D([5998,5642,5667,6220],0); -ELEMENTS[54601] = Fluid3D([5667,5998,6220,5926],0); -ELEMENTS[54602] = Fluid3D([6220,5667,5926,5885],0); -ELEMENTS[54603] = Fluid3D([17367,17509,17803,17793],0); -ELEMENTS[54604] = Fluid3D([4485,4126,3911,3752],0); -ELEMENTS[54605] = Fluid3D([4473,4406,4023,4469],0); -ELEMENTS[54606] = Fluid3D([15432,15318,15810,15002],0); -ELEMENTS[54607] = Fluid3D([9636,9571,9398,8615],0); -ELEMENTS[54608] = Fluid3D([4701,5151,5370,5030],0); -ELEMENTS[54609] = Fluid3D([10614,10240,10978,11147],0); -ELEMENTS[54610] = Fluid3D([10240,10978,11147,10570],0); -ELEMENTS[54611] = Fluid3D([10240,10978,10570,10258],0); -ELEMENTS[54612] = Fluid3D([10570,10240,10258,9785],0); -ELEMENTS[54613] = Fluid3D([10258,10570,9785,10303],0); -ELEMENTS[54614] = Fluid3D([10570,10240,9785,9973],0); -ELEMENTS[54615] = Fluid3D([11147,10240,10570,10542],0); -ELEMENTS[54616] = Fluid3D([10614,10240,11147,9957],0); -ELEMENTS[54617] = Fluid3D([10614,10240,9957,9379],0); -ELEMENTS[54618] = Fluid3D([10240,11147,9957,10542],0); -ELEMENTS[54619] = Fluid3D([9957,10240,10542,10272],0); -ELEMENTS[54620] = Fluid3D([10542,9957,10272,9559],0); -ELEMENTS[54621] = Fluid3D([10542,9957,9559,10410],0); -ELEMENTS[54622] = Fluid3D([9957,10272,9559,9973],0); -ELEMENTS[54623] = Fluid3D([9957,10272,9973,10240],0); -ELEMENTS[54624] = Fluid3D([10272,9559,9973,10542],0); -ELEMENTS[54625] = Fluid3D([9973,10272,10542,10962],0); -ELEMENTS[54626] = Fluid3D([9973,10272,10962,10537],0); -ELEMENTS[54627] = Fluid3D([10272,10962,10537,10570],0); -ELEMENTS[54628] = Fluid3D([10962,10537,10570,11219],0); -ELEMENTS[54629] = Fluid3D([9973,10272,10537,10570],0); -ELEMENTS[54630] = Fluid3D([10537,10570,11219,9785],0); -ELEMENTS[54631] = Fluid3D([10537,10570,9785,9973],0); -ELEMENTS[54632] = Fluid3D([10962,9973,10537,9785],0); -ELEMENTS[54633] = Fluid3D([10537,10962,9785,11219],0); -ELEMENTS[54634] = Fluid3D([10272,10542,10962,10570],0); -ELEMENTS[54635] = Fluid3D([10542,9957,10410,10614],0); -ELEMENTS[54636] = Fluid3D([10542,9957,10614,11147],0); -ELEMENTS[54637] = Fluid3D([9957,10410,10614,9379],0); -ELEMENTS[54638] = Fluid3D([10410,10614,9379,9752],0); -ELEMENTS[54639] = Fluid3D([10410,10614,9752,11254],0); -ELEMENTS[54640] = Fluid3D([10240,10542,10272,10570],0); -ELEMENTS[54641] = Fluid3D([10258,10570,10303,11219],0); -ELEMENTS[54642] = Fluid3D([16741,17107,17048,17234],0); -ELEMENTS[54643] = Fluid3D([6088,6854,6318,6465],0); -ELEMENTS[54644] = Fluid3D([6318,6088,6465,5801],0); -ELEMENTS[54645] = Fluid3D([6318,6088,5801,5457],0); -ELEMENTS[54646] = Fluid3D([6318,6088,5457,5758],0); -ELEMENTS[54647] = Fluid3D([14617,14962,14798,14049],0); -ELEMENTS[54648] = Fluid3D([14617,14962,14049,14180],0); -ELEMENTS[54649] = Fluid3D([12849,12102,12016,12551],0); -ELEMENTS[54650] = Fluid3D([12102,12016,12551,11474],0); -ELEMENTS[54651] = Fluid3D([14632,13970,13731,13814],0); -ELEMENTS[54652] = Fluid3D([10709,11582,11830,11254],0); -ELEMENTS[54653] = Fluid3D([15950,15459,15658,14933],0); -ELEMENTS[54654] = Fluid3D([7164,7181,6271,6749],0); -ELEMENTS[54655] = Fluid3D([2338,2531,2639,2440],0); -ELEMENTS[54656] = Fluid3D([2531,2639,2440,2527],0); -ELEMENTS[54657] = Fluid3D([6777,6793,6729,7587],0); -ELEMENTS[54658] = Fluid3D([6729,6777,7587,7268],0); -ELEMENTS[54659] = Fluid3D([6729,6777,7268,6311],0); -ELEMENTS[54660] = Fluid3D([7587,6729,7268,7422],0); -ELEMENTS[54661] = Fluid3D([6729,7268,7422,6542],0); -ELEMENTS[54662] = Fluid3D([7268,7422,6542,7186],0); -ELEMENTS[54663] = Fluid3D([7268,7422,7186,7765],0); -ELEMENTS[54664] = Fluid3D([7268,7422,7765,7587],0); -ELEMENTS[54665] = Fluid3D([7186,7268,7765,6961],0); -ELEMENTS[54666] = Fluid3D([7268,7765,6961,7561],0); -ELEMENTS[54667] = Fluid3D([7268,7765,7561,7587],0); -ELEMENTS[54668] = Fluid3D([11755,12585,12785,12239],0); -ELEMENTS[54669] = Fluid3D([11335,10806,11148,11988],0); -ELEMENTS[54670] = Fluid3D([11148,11335,11988,11879],0); -ELEMENTS[54671] = Fluid3D([12180,11326,11185,11783],0); -ELEMENTS[54672] = Fluid3D([7514,7141,7221,8091],0); -ELEMENTS[54673] = Fluid3D([1958,2071,2047,1848],0); -ELEMENTS[54674] = Fluid3D([7079,7520,6631,7188],0); -ELEMENTS[54675] = Fluid3D([11879,12109,11988,13048],0); -ELEMENTS[54676] = Fluid3D([11879,12109,13048,12634],0); -ELEMENTS[54677] = Fluid3D([11879,12109,12634,12247],0); -ELEMENTS[54678] = Fluid3D([12109,12634,12247,13303],0); -ELEMENTS[54679] = Fluid3D([12109,13048,12634,13303],0); -ELEMENTS[54680] = Fluid3D([4793,4220,4722,4693],0); -ELEMENTS[54681] = Fluid3D([8669,9336,8365,9093],0); -ELEMENTS[54682] = Fluid3D([7225,6604,7450,6923],0); -ELEMENTS[54683] = Fluid3D([4495,4098,4615,4805],0); -ELEMENTS[54684] = Fluid3D([3130,3536,3513,3286],0); -ELEMENTS[54685] = Fluid3D([3353,2944,3190,3273],0); -ELEMENTS[54686] = Fluid3D([12723,12158,13053,13027],0); -ELEMENTS[54687] = Fluid3D([14797,15301,14931,14709],0); -ELEMENTS[54688] = Fluid3D([13153,12641,13198,12388],0); -ELEMENTS[54689] = Fluid3D([12641,13198,12388,12311],0); -ELEMENTS[54690] = Fluid3D([12388,12641,12311,11703],0); -ELEMENTS[54691] = Fluid3D([12641,12311,11703,12760],0); -ELEMENTS[54692] = Fluid3D([12311,12388,11703,11935],0); -ELEMENTS[54693] = Fluid3D([11703,12311,11935,12033],0); -ELEMENTS[54694] = Fluid3D([12641,13198,12311,13616],0); -ELEMENTS[54695] = Fluid3D([11703,12311,12033,12760],0); -ELEMENTS[54696] = Fluid3D([17755,17821,17843,18057],0); -ELEMENTS[54697] = Fluid3D([14715,15090,15587,14854],0); -ELEMENTS[54698] = Fluid3D([7776,8590,8785,7970],0); -ELEMENTS[54699] = Fluid3D([8796,8437,9384,8752],0); -ELEMENTS[54700] = Fluid3D([16692,16673,16563,16872],0); -ELEMENTS[54701] = Fluid3D([16563,16692,16872,17171],0); -ELEMENTS[54702] = Fluid3D([7853,7889,7418,6926],0); -ELEMENTS[54703] = Fluid3D([7853,7889,6926,6979],0); -ELEMENTS[54704] = Fluid3D([7853,7889,6979,7652],0); -ELEMENTS[54705] = Fluid3D([12146,12971,12700,12945],0); -ELEMENTS[54706] = Fluid3D([4570,4437,4112,4546],0); -ELEMENTS[54707] = Fluid3D([7650,7899,8405,8618],0); -ELEMENTS[54708] = Fluid3D([2288,2481,2276,2649],0); -ELEMENTS[54709] = Fluid3D([15480,14781,15140,15297],0); -ELEMENTS[54710] = Fluid3D([6736,6781,6076,6842],0); -ELEMENTS[54711] = Fluid3D([6736,6781,6842,7466],0); -ELEMENTS[54712] = Fluid3D([6736,6781,7466,7866],0); -ELEMENTS[54713] = Fluid3D([6247,6512,7036,6767],0); -ELEMENTS[54714] = Fluid3D([14630,14489,14070,14482],0); -ELEMENTS[54715] = Fluid3D([14070,14630,14482,15147],0); -ELEMENTS[54716] = Fluid3D([17885,17808,17662,17660],0); -ELEMENTS[54717] = Fluid3D([16252,16297,15847,16468],0); -ELEMENTS[54718] = Fluid3D([16778,16869,16426,16500],0); -ELEMENTS[54719] = Fluid3D([8114,8010,7721,8405],0); -ELEMENTS[54720] = Fluid3D([8114,8010,8405,8596],0); -ELEMENTS[54721] = Fluid3D([4262,4164,4528,3900],0); -ELEMENTS[54722] = Fluid3D([4359,4090,3826,3560],0); -ELEMENTS[54723] = Fluid3D([15365,15725,15995,16165],0); -ELEMENTS[54724] = Fluid3D([8859,8373,8029,8684],0); -ELEMENTS[54725] = Fluid3D([5536,5672,5447,5245],0); -ELEMENTS[54726] = Fluid3D([9431,9017,9628,10766],0); -ELEMENTS[54727] = Fluid3D([6130,6515,5821,6364],0); -ELEMENTS[54728] = Fluid3D([11440,12346,11610,11732],0); -ELEMENTS[54729] = Fluid3D([3411,3037,3197,3057],0); -ELEMENTS[54730] = Fluid3D([15438,15016,15616,15341],0); -ELEMENTS[54731] = Fluid3D([7881,7974,7669,7127],0); -ELEMENTS[54732] = Fluid3D([10368,9794,10686,11038],0); -ELEMENTS[54733] = Fluid3D([2581,2379,2322,2450],0); -ELEMENTS[54734] = Fluid3D([3373,3641,3138,3320],0); -ELEMENTS[54735] = Fluid3D([8462,7664,7848,7574],0); -ELEMENTS[54736] = Fluid3D([7848,8462,7574,8671],0); -ELEMENTS[54737] = Fluid3D([6067,5865,6296,6614],0); -ELEMENTS[54738] = Fluid3D([17293,17155,17031,16697],0); -ELEMENTS[54739] = Fluid3D([17155,17031,16697,16764],0); -ELEMENTS[54740] = Fluid3D([17155,17031,16764,17163],0); -ELEMENTS[54741] = Fluid3D([16697,17155,16764,16750],0); -ELEMENTS[54742] = Fluid3D([17155,16764,16750,17163],0); -ELEMENTS[54743] = Fluid3D([16764,16697,16750,16106],0); -ELEMENTS[54744] = Fluid3D([16764,16750,17163,16667],0); -ELEMENTS[54745] = Fluid3D([16764,16750,16667,16106],0); -ELEMENTS[54746] = Fluid3D([17163,16764,16667,17031],0); -ELEMENTS[54747] = Fluid3D([17031,16697,16764,16394],0); -ELEMENTS[54748] = Fluid3D([16697,16764,16394,16106],0); -ELEMENTS[54749] = Fluid3D([17293,17155,16697,16719],0); -ELEMENTS[54750] = Fluid3D([16764,16667,17031,16394],0); -ELEMENTS[54751] = Fluid3D([16764,16667,16394,16106],0); -ELEMENTS[54752] = Fluid3D([4154,4596,4639,4348],0); -ELEMENTS[54753] = Fluid3D([17858,17970,17896,17687],0); -ELEMENTS[54754] = Fluid3D([17858,17970,17687,17822],0); -ELEMENTS[54755] = Fluid3D([17970,17896,17687,18046],0); -ELEMENTS[54756] = Fluid3D([17687,17970,18046,17822],0); -ELEMENTS[54757] = Fluid3D([6740,6756,6058,6518],0); -ELEMENTS[54758] = Fluid3D([16133,15906,16237,15592],0); -ELEMENTS[54759] = Fluid3D([1868,1783,1706,1705],0); -ELEMENTS[54760] = Fluid3D([10538,11421,11109,10504],0); -ELEMENTS[54761] = Fluid3D([7640,8479,8029,7672],0); -ELEMENTS[54762] = Fluid3D([4810,5082,5411,5267],0); -ELEMENTS[54763] = Fluid3D([15487,15789,15841,16019],0); -ELEMENTS[54764] = Fluid3D([15487,15789,16019,16313],0); -ELEMENTS[54765] = Fluid3D([18682,18652,18657,18672],0); -ELEMENTS[54766] = Fluid3D([18682,18652,18672,18690],0); -ELEMENTS[54767] = Fluid3D([18652,18657,18672,18626],0); -ELEMENTS[54768] = Fluid3D([16556,16850,16539,16177],0); -ELEMENTS[54769] = Fluid3D([10704,10195,11307,10689],0); -ELEMENTS[54770] = Fluid3D([11307,10704,10689,11781],0); -ELEMENTS[54771] = Fluid3D([10195,11307,10689,10144],0); -ELEMENTS[54772] = Fluid3D([10704,10195,10689,9725],0); -ELEMENTS[54773] = Fluid3D([1783,1705,1789,1680],0); -ELEMENTS[54774] = Fluid3D([1783,1705,1680,1606],0); -ELEMENTS[54775] = Fluid3D([18588,18652,18672,18626],0); -ELEMENTS[54776] = Fluid3D([9457,8995,8258,9090],0); -ELEMENTS[54777] = Fluid3D([15208,15498,15662,15741],0); -ELEMENTS[54778] = Fluid3D([15368,14695,14618,15489],0); -ELEMENTS[54779] = Fluid3D([15191,15725,15798,15995],0); -ELEMENTS[54780] = Fluid3D([11581,11345,12113,12638],0); -ELEMENTS[54781] = Fluid3D([4570,4112,4204,4742],0); -ELEMENTS[54782] = Fluid3D([5954,6530,6925,6220],0); -ELEMENTS[54783] = Fluid3D([14063,14879,14366,14422],0); -ELEMENTS[54784] = Fluid3D([6163,5553,5842,5704],0); -ELEMENTS[54785] = Fluid3D([5681,5388,5935,5784],0); -ELEMENTS[54786] = Fluid3D([9818,10447,9936,9697],0); -ELEMENTS[54787] = Fluid3D([14502,14586,13986,14649],0); -ELEMENTS[54788] = Fluid3D([5819,6311,6017,6729],0); -ELEMENTS[54789] = Fluid3D([5744,6233,5816,5421],0); -ELEMENTS[54790] = Fluid3D([4132,4324,4467,4637],0); -ELEMENTS[54791] = Fluid3D([13608,14312,13877,14378],0); -ELEMENTS[54792] = Fluid3D([13877,13608,14378,13537],0); -ELEMENTS[54793] = Fluid3D([15501,15009,15785,15079],0); -ELEMENTS[54794] = Fluid3D([15501,15009,15079,14514],0); -ELEMENTS[54795] = Fluid3D([15785,15501,15079,15917],0); -ELEMENTS[54796] = Fluid3D([15501,15079,15917,15659],0); -ELEMENTS[54797] = Fluid3D([15501,15079,15659,15233],0); -ELEMENTS[54798] = Fluid3D([15501,15079,15233,14514],0); -ELEMENTS[54799] = Fluid3D([15079,15917,15659,15122],0); -ELEMENTS[54800] = Fluid3D([15079,15659,15233,14674],0); -ELEMENTS[54801] = Fluid3D([16437,16007,16579,15815],0); -ELEMENTS[54802] = Fluid3D([8832,9352,9960,9566],0); -ELEMENTS[54803] = Fluid3D([8195,8991,9261,8645],0); -ELEMENTS[54804] = Fluid3D([4879,5295,5018,5022],0); -ELEMENTS[54805] = Fluid3D([17278,16694,17029,17077],0); -ELEMENTS[54806] = Fluid3D([8022,7927,7635,8747],0); -ELEMENTS[54807] = Fluid3D([12493,12758,12913,12023],0); -ELEMENTS[54808] = Fluid3D([12307,11311,11413,11552],0); -ELEMENTS[54809] = Fluid3D([10905,10447,11521,11277],0); -ELEMENTS[54810] = Fluid3D([2283,2261,2034,2193],0); -ELEMENTS[54811] = Fluid3D([2283,2261,2193,2550],0); -ELEMENTS[54812] = Fluid3D([14877,14845,15243,15677],0); -ELEMENTS[54813] = Fluid3D([15871,15983,15526,15999],0); -ELEMENTS[54814] = Fluid3D([3936,4122,4297,4294],0); -ELEMENTS[54815] = Fluid3D([14555,15214,15353,15420],0); -ELEMENTS[54816] = Fluid3D([18616,18555,18647,18574],0); -ELEMENTS[54817] = Fluid3D([17600,17919,17804,17451],0); -ELEMENTS[54818] = Fluid3D([16927,17230,17048,17392],0); -ELEMENTS[54819] = Fluid3D([16927,17230,17392,17125],0); -ELEMENTS[54820] = Fluid3D([16927,17230,17125,17093],0); -ELEMENTS[54821] = Fluid3D([17392,16927,17125,17142],0); -ELEMENTS[54822] = Fluid3D([16927,17125,17142,16684],0); -ELEMENTS[54823] = Fluid3D([16927,17125,16684,17093],0); -ELEMENTS[54824] = Fluid3D([17230,17392,17125,17404],0); -ELEMENTS[54825] = Fluid3D([3554,3517,3180,3661],0); -ELEMENTS[54826] = Fluid3D([18275,18109,18201,18093],0); -ELEMENTS[54827] = Fluid3D([18201,18275,18093,18342],0); -ELEMENTS[54828] = Fluid3D([10973,11255,10354,11736],0); -ELEMENTS[54829] = Fluid3D([10973,11255,11736,12151],0); -ELEMENTS[54830] = Fluid3D([11255,11736,12151,12221],0); -ELEMENTS[54831] = Fluid3D([10973,11255,12151,11455],0); -ELEMENTS[54832] = Fluid3D([11255,11736,12221,10927],0); -ELEMENTS[54833] = Fluid3D([11255,11736,10927,10354],0); -ELEMENTS[54834] = Fluid3D([10296,10866,10634,9681],0); -ELEMENTS[54835] = Fluid3D([10296,10866,9681,10241],0); -ELEMENTS[54836] = Fluid3D([10866,10634,9681,10241],0); -ELEMENTS[54837] = Fluid3D([16782,17089,16880,17349],0); -ELEMENTS[54838] = Fluid3D([14570,14789,14045,14767],0); -ELEMENTS[54839] = Fluid3D([13149,12794,13336,13807],0); -ELEMENTS[54840] = Fluid3D([4550,4968,4385,5038],0); -ELEMENTS[54841] = Fluid3D([3795,3649,3459,3306],0); -ELEMENTS[54842] = Fluid3D([16498,16097,16608,16381],0); -ELEMENTS[54843] = Fluid3D([3095,3369,2964,3112],0); -ELEMENTS[54844] = Fluid3D([10425,9440,9887,9990],0); -ELEMENTS[54845] = Fluid3D([9440,9887,9990,9074],0); -ELEMENTS[54846] = Fluid3D([9887,9990,9074,8997],0); -ELEMENTS[54847] = Fluid3D([9074,9887,8997,8506],0); -ELEMENTS[54848] = Fluid3D([8997,9074,8506,7849],0); -ELEMENTS[54849] = Fluid3D([9990,9074,8997,9368],0); -ELEMENTS[54850] = Fluid3D([9990,9440,9074,8794],0); -ELEMENTS[54851] = Fluid3D([9440,9074,8794,8075],0); -ELEMENTS[54852] = Fluid3D([9440,9887,9074,9051],0); -ELEMENTS[54853] = Fluid3D([9887,9074,9051,8506],0); -ELEMENTS[54854] = Fluid3D([9074,9051,8506,8075],0); -ELEMENTS[54855] = Fluid3D([18442,18282,18243,18191],0); -ELEMENTS[54856] = Fluid3D([15318,15014,14486,14500],0); -ELEMENTS[54857] = Fluid3D([11533,10627,11268,11634],0); -ELEMENTS[54858] = Fluid3D([11729,10830,11450,11030],0); -ELEMENTS[54859] = Fluid3D([3691,3513,3363,3536],0); -ELEMENTS[54860] = Fluid3D([3691,3513,3536,3682],0); -ELEMENTS[54861] = Fluid3D([11311,12040,11755,11552],0); -ELEMENTS[54862] = Fluid3D([2373,2523,2494,2229],0); -ELEMENTS[54863] = Fluid3D([16697,16921,16863,17031],0); -ELEMENTS[54864] = Fluid3D([12970,13067,12420,13330],0); -ELEMENTS[54865] = Fluid3D([11088,11218,10870,10191],0); -ELEMENTS[54866] = Fluid3D([16347,16436,16099,15893],0); -ELEMENTS[54867] = Fluid3D([16347,16436,15893,15876],0); -ELEMENTS[54868] = Fluid3D([15893,16347,15876,16311],0); -ELEMENTS[54869] = Fluid3D([16744,16955,16515,16818],0); -ELEMENTS[54870] = Fluid3D([16515,16744,16818,16363],0); -ELEMENTS[54871] = Fluid3D([11050,10433,10435,11430],0); -ELEMENTS[54872] = Fluid3D([11050,10433,11430,11136],0); -ELEMENTS[54873] = Fluid3D([11344,11531,10980,11074],0); -ELEMENTS[54874] = Fluid3D([11344,11531,11074,11556],0); -ELEMENTS[54875] = Fluid3D([16506,16065,16390,15925],0); -ELEMENTS[54876] = Fluid3D([4682,4223,4349,4780],0); -ELEMENTS[54877] = Fluid3D([4682,4223,4780,4977],0); -ELEMENTS[54878] = Fluid3D([12009,12269,11199,12064],0); -ELEMENTS[54879] = Fluid3D([16721,16676,17191,17010],0); -ELEMENTS[54880] = Fluid3D([16721,16676,17010,16503],0); -ELEMENTS[54881] = Fluid3D([5893,5798,6251,6661],0); -ELEMENTS[54882] = Fluid3D([5364,4874,4689,5103],0); -ELEMENTS[54883] = Fluid3D([4874,4689,5103,5078],0); -ELEMENTS[54884] = Fluid3D([15352,15322,15875,15107],0); -ELEMENTS[54885] = Fluid3D([10173,9780,10817,10825],0); -ELEMENTS[54886] = Fluid3D([2394,2570,2642,2417],0); -ELEMENTS[54887] = Fluid3D([16709,16933,16436,16270],0); -ELEMENTS[54888] = Fluid3D([15683,15948,15545,16053],0); -ELEMENTS[54889] = Fluid3D([9811,8807,8756,9531],0); -ELEMENTS[54890] = Fluid3D([9811,8807,9531,8759],0); -ELEMENTS[54891] = Fluid3D([9883,8898,9380,9563],0); -ELEMENTS[54892] = Fluid3D([4138,3693,3830,3725],0); -ELEMENTS[54893] = Fluid3D([7378,8124,8228,7545],0); -ELEMENTS[54894] = Fluid3D([13460,12988,12614,13462],0); -ELEMENTS[54895] = Fluid3D([13460,12988,13462,13661],0); -ELEMENTS[54896] = Fluid3D([17437,17613,17565,17180],0); -ELEMENTS[54897] = Fluid3D([17437,17613,17180,17291],0); -ELEMENTS[54898] = Fluid3D([17180,17437,17291,17380],0); -ELEMENTS[54899] = Fluid3D([17180,17437,17380,17164],0); -ELEMENTS[54900] = Fluid3D([17565,17437,17180,17319],0); -ELEMENTS[54901] = Fluid3D([17437,17180,17319,17164],0); -ELEMENTS[54902] = Fluid3D([17565,17437,17319,17625],0); -ELEMENTS[54903] = Fluid3D([17437,17319,17625,17164],0); -ELEMENTS[54904] = Fluid3D([14216,13546,13274,13921],0); -ELEMENTS[54905] = Fluid3D([13546,13274,13921,12993],0); -ELEMENTS[54906] = Fluid3D([18479,18294,18422,18343],0); -ELEMENTS[54907] = Fluid3D([18479,18294,18343,18410],0); -ELEMENTS[54908] = Fluid3D([18294,18422,18343,18274],0); -ELEMENTS[54909] = Fluid3D([18294,18343,18410,18096],0); -ELEMENTS[54910] = Fluid3D([18294,18343,18096,18274],0); -ELEMENTS[54911] = Fluid3D([4906,4493,4198,4529],0); -ELEMENTS[54912] = Fluid3D([9958,10912,10130,11168],0); -ELEMENTS[54913] = Fluid3D([2751,2898,3107,2957],0); -ELEMENTS[54914] = Fluid3D([3107,2751,2957,3132],0); -ELEMENTS[54915] = Fluid3D([12412,12829,13516,12707],0); -ELEMENTS[54916] = Fluid3D([15299,15480,15140,15464],0); -ELEMENTS[54917] = Fluid3D([17547,17778,17550,17918],0); -ELEMENTS[54918] = Fluid3D([14693,14548,15015,15536],0); -ELEMENTS[54919] = Fluid3D([16640,17102,17135,17167],0); -ELEMENTS[54920] = Fluid3D([13659,12747,13614,13102],0); -ELEMENTS[54921] = Fluid3D([2171,2060,2087,2010],0); -ELEMENTS[54922] = Fluid3D([2171,2060,2010,2061],0); -ELEMENTS[54923] = Fluid3D([10575,10160,10800,10369],0); -ELEMENTS[54924] = Fluid3D([16622,16475,16638,17045],0); -ELEMENTS[54925] = Fluid3D([4308,4297,3965,3886],0); -ELEMENTS[54926] = Fluid3D([15325,14658,14791,14622],0); -ELEMENTS[54927] = Fluid3D([14791,15325,14622,15096],0); -ELEMENTS[54928] = Fluid3D([14622,14791,15096,14258],0); -ELEMENTS[54929] = Fluid3D([14791,15325,15096,15522],0); -ELEMENTS[54930] = Fluid3D([14658,14791,14622,13806],0); -ELEMENTS[54931] = Fluid3D([15938,15793,15966,15355],0); -ELEMENTS[54932] = Fluid3D([6557,6966,7403,6821],0); -ELEMENTS[54933] = Fluid3D([7403,6557,6821,6223],0); -ELEMENTS[54934] = Fluid3D([13414,12505,13517,12702],0); -ELEMENTS[54935] = Fluid3D([12267,11772,12949,11613],0); -ELEMENTS[54936] = Fluid3D([13627,14353,13851,14148],0); -ELEMENTS[54937] = Fluid3D([13627,14353,14148,13419],0); -ELEMENTS[54938] = Fluid3D([11636,12643,12359,11546],0); -ELEMENTS[54939] = Fluid3D([6538,6216,7117,7260],0); -ELEMENTS[54940] = Fluid3D([17936,17904,17909,18264],0); -ELEMENTS[54941] = Fluid3D([6476,6112,5992,5742],0); -ELEMENTS[54942] = Fluid3D([5992,6476,5742,6005],0); -ELEMENTS[54943] = Fluid3D([6476,6112,5742,6495],0); -ELEMENTS[54944] = Fluid3D([11927,10945,10869,10727],0); -ELEMENTS[54945] = Fluid3D([10945,10869,10727,9795],0); -ELEMENTS[54946] = Fluid3D([11927,10945,10727,11676],0); -ELEMENTS[54947] = Fluid3D([10727,10945,9795,10435],0); -ELEMENTS[54948] = Fluid3D([10727,10945,10435,11676],0); -ELEMENTS[54949] = Fluid3D([10940,10668,11509,11562],0); -ELEMENTS[54950] = Fluid3D([10940,10668,11562,10157],0); -ELEMENTS[54951] = Fluid3D([11509,10940,11562,11228],0); -ELEMENTS[54952] = Fluid3D([10940,11562,11228,11821],0); -ELEMENTS[54953] = Fluid3D([10940,11562,11821,10791],0); -ELEMENTS[54954] = Fluid3D([10940,11562,10791,10157],0); -ELEMENTS[54955] = Fluid3D([10940,10668,10157,9837],0); -ELEMENTS[54956] = Fluid3D([10668,11509,11562,11520],0); -ELEMENTS[54957] = Fluid3D([11562,10668,11520,10157],0); -ELEMENTS[54958] = Fluid3D([10668,11509,11520,10336],0); -ELEMENTS[54959] = Fluid3D([10668,11520,10157,10293],0); -ELEMENTS[54960] = Fluid3D([10157,10668,10293,9685],0); -ELEMENTS[54961] = Fluid3D([10157,10668,9685,9837],0); -ELEMENTS[54962] = Fluid3D([4956,4851,5394,5711],0); -ELEMENTS[54963] = Fluid3D([3534,3769,3966,3299],0); -ELEMENTS[54964] = Fluid3D([10277,9499,9265,10456],0); -ELEMENTS[54965] = Fluid3D([10277,9499,10456,10502],0); -ELEMENTS[54966] = Fluid3D([9265,10277,10456,9959],0); -ELEMENTS[54967] = Fluid3D([5236,5441,5035,4745],0); -ELEMENTS[54968] = Fluid3D([16006,16242,16483,16688],0); -ELEMENTS[54969] = Fluid3D([18608,18629,18666,18632],0); -ELEMENTS[54970] = Fluid3D([16603,16312,16874,16444],0); -ELEMENTS[54971] = Fluid3D([9687,10728,9791,10319],0); -ELEMENTS[54972] = Fluid3D([2960,3047,3277,3314],0); -ELEMENTS[54973] = Fluid3D([3277,2960,3314,3249],0); -ELEMENTS[54974] = Fluid3D([2960,3314,3249,3061],0); -ELEMENTS[54975] = Fluid3D([3277,2960,3249,3324],0); -ELEMENTS[54976] = Fluid3D([3249,3277,3324,3588],0); -ELEMENTS[54977] = Fluid3D([3324,3249,3588,3255],0); -ELEMENTS[54978] = Fluid3D([3324,3249,3255,2834],0); -ELEMENTS[54979] = Fluid3D([3249,3588,3255,3314],0); -ELEMENTS[54980] = Fluid3D([3255,3249,3314,3061],0); -ELEMENTS[54981] = Fluid3D([3588,3324,3255,3693],0); -ELEMENTS[54982] = Fluid3D([3249,3277,3588,3314],0); -ELEMENTS[54983] = Fluid3D([3255,3588,3693,3314],0); -ELEMENTS[54984] = Fluid3D([3255,3249,3061,2834],0); -ELEMENTS[54985] = Fluid3D([2960,3249,3324,2834],0); -ELEMENTS[54986] = Fluid3D([2960,3249,2834,3061],0); -ELEMENTS[54987] = Fluid3D([3123,3289,3127,3592],0); -ELEMENTS[54988] = Fluid3D([10077,10330,9230,9819],0); -ELEMENTS[54989] = Fluid3D([3611,3269,3361,3441],0); -ELEMENTS[54990] = Fluid3D([3361,3611,3441,3851],0); -ELEMENTS[54991] = Fluid3D([7585,8081,7299,7395],0); -ELEMENTS[54992] = Fluid3D([13480,13198,13616,14237],0); -ELEMENTS[54993] = Fluid3D([10043,10746,10957,10527],0); -ELEMENTS[54994] = Fluid3D([1802,1706,1644,1705],0); -ELEMENTS[54995] = Fluid3D([3635,3584,3658,3235],0); -ELEMENTS[54996] = Fluid3D([13312,12839,13618,13099],0); -ELEMENTS[54997] = Fluid3D([2741,2956,3088,3060],0); -ELEMENTS[54998] = Fluid3D([4288,4339,3922,3642],0); -ELEMENTS[54999] = Fluid3D([3548,3609,3175,3445],0); -ELEMENTS[55000] = Fluid3D([15221,15308,15802,15840],0); -ELEMENTS[55001] = Fluid3D([4183,4684,4610,4101],0); -ELEMENTS[55002] = Fluid3D([16754,16265,16553,16477],0); -ELEMENTS[55003] = Fluid3D([16754,16265,16477,16502],0); -ELEMENTS[55004] = Fluid3D([16553,16754,16477,16906],0); -ELEMENTS[55005] = Fluid3D([16754,16477,16906,17077],0); -ELEMENTS[55006] = Fluid3D([16477,16553,16906,16716],0); -ELEMENTS[55007] = Fluid3D([16477,16754,16502,17077],0); -ELEMENTS[55008] = Fluid3D([18039,17845,18077,17986],0); -ELEMENTS[55009] = Fluid3D([17845,18077,17986,18167],0); -ELEMENTS[55010] = Fluid3D([18077,18039,17986,18226],0); -ELEMENTS[55011] = Fluid3D([17986,18077,18226,18167],0); -ELEMENTS[55012] = Fluid3D([18039,17845,17986,17779],0); -ELEMENTS[55013] = Fluid3D([18039,17986,18226,18160],0); -ELEMENTS[55014] = Fluid3D([17986,18226,18160,18161],0); -ELEMENTS[55015] = Fluid3D([18226,18160,18161,18340],0); -ELEMENTS[55016] = Fluid3D([18161,18226,18340,17986],0); -ELEMENTS[55017] = Fluid3D([18160,17986,18161,17879],0); -ELEMENTS[55018] = Fluid3D([18077,18226,18167,18300],0); -ELEMENTS[55019] = Fluid3D([18167,18077,18300,17969],0); -ELEMENTS[55020] = Fluid3D([18077,18226,18300,18039],0); -ELEMENTS[55021] = Fluid3D([17986,18161,17879,17825],0); -ELEMENTS[55022] = Fluid3D([18161,18160,17879,18231],0); -ELEMENTS[55023] = Fluid3D([18161,18160,18231,18340],0); -ELEMENTS[55024] = Fluid3D([17879,18161,18231,18127],0); -ELEMENTS[55025] = Fluid3D([18231,18161,18340,18382],0); -ELEMENTS[55026] = Fluid3D([18231,18161,18382,18127],0); -ELEMENTS[55027] = Fluid3D([18161,18340,18382,18225],0); -ELEMENTS[55028] = Fluid3D([18161,18340,18225,18167],0); -ELEMENTS[55029] = Fluid3D([18382,18161,18225,18159],0); -ELEMENTS[55030] = Fluid3D([18161,18225,18159,17975],0); -ELEMENTS[55031] = Fluid3D([18161,18225,17975,18167],0); -ELEMENTS[55032] = Fluid3D([18225,18159,17975,18035],0); -ELEMENTS[55033] = Fluid3D([18159,18161,17975,17879],0); -ELEMENTS[55034] = Fluid3D([18161,17975,17879,17825],0); -ELEMENTS[55035] = Fluid3D([17975,18159,17879,18035],0); -ELEMENTS[55036] = Fluid3D([18159,18161,17879,18127],0); -ELEMENTS[55037] = Fluid3D([17879,18159,18127,18035],0); -ELEMENTS[55038] = Fluid3D([18159,18127,18035,18284],0); -ELEMENTS[55039] = Fluid3D([18159,18127,18284,18382],0); -ELEMENTS[55040] = Fluid3D([18035,18159,18284,18225],0); -ELEMENTS[55041] = Fluid3D([18159,18284,18225,18382],0); -ELEMENTS[55042] = Fluid3D([18159,18161,18127,18382],0); -ELEMENTS[55043] = Fluid3D([17975,17879,17825,17706],0); -ELEMENTS[55044] = Fluid3D([17975,17879,17706,18035],0); -ELEMENTS[55045] = Fluid3D([17825,17975,17706,18033],0); -ELEMENTS[55046] = Fluid3D([17825,17975,18033,18167],0); -ELEMENTS[55047] = Fluid3D([18161,18340,18167,17986],0); -ELEMENTS[55048] = Fluid3D([13791,13990,12869,13282],0); -ELEMENTS[55049] = Fluid3D([16102,15815,16514,16035],0); -ELEMENTS[55050] = Fluid3D([16102,15815,16035,15617],0); -ELEMENTS[55051] = Fluid3D([15815,16514,16035,16579],0); -ELEMENTS[55052] = Fluid3D([15815,16035,15617,15378],0); -ELEMENTS[55053] = Fluid3D([15815,16035,15378,15585],0); -ELEMENTS[55054] = Fluid3D([8819,8035,8353,8202],0); -ELEMENTS[55055] = Fluid3D([4936,5340,4747,5205],0); -ELEMENTS[55056] = Fluid3D([13982,14647,14412,13400],0); -ELEMENTS[55057] = Fluid3D([4141,3786,3581,3949],0); -ELEMENTS[55058] = Fluid3D([17423,17144,17457,16810],0); -ELEMENTS[55059] = Fluid3D([11895,12216,12830,12849],0); -ELEMENTS[55060] = Fluid3D([12154,12928,12303,12253],0); -ELEMENTS[55061] = Fluid3D([12154,12928,12253,11601],0); -ELEMENTS[55062] = Fluid3D([12154,12928,11601,12750],0); -ELEMENTS[55063] = Fluid3D([12253,12154,11601,11424],0); -ELEMENTS[55064] = Fluid3D([14022,13607,14174,13587],0); -ELEMENTS[55065] = Fluid3D([15281,15693,15219,15928],0); -ELEMENTS[55066] = Fluid3D([15281,15693,15928,15831],0); -ELEMENTS[55067] = Fluid3D([8712,8890,8965,9858],0); -ELEMENTS[55068] = Fluid3D([11717,11388,10829,11901],0); -ELEMENTS[55069] = Fluid3D([11388,10829,11901,11345],0); -ELEMENTS[55070] = Fluid3D([3974,4351,4259,4425],0); -ELEMENTS[55071] = Fluid3D([15344,16116,15722,15784],0); -ELEMENTS[55072] = Fluid3D([16384,16173,16738,16612],0); -ELEMENTS[55073] = Fluid3D([16384,16173,16612,16085],0); -ELEMENTS[55074] = Fluid3D([16612,16384,16085,16350],0); -ELEMENTS[55075] = Fluid3D([16384,16173,16085,15580],0); -ELEMENTS[55076] = Fluid3D([16612,16384,16350,16876],0); -ELEMENTS[55077] = Fluid3D([16612,16384,16876,16931],0); -ELEMENTS[55078] = Fluid3D([14876,14340,14611,14806],0); -ELEMENTS[55079] = Fluid3D([14131,14769,14539,14397],0); -ELEMENTS[55080] = Fluid3D([17222,17554,17375,17317],0); -ELEMENTS[55081] = Fluid3D([17222,17554,17317,17333],0); -ELEMENTS[55082] = Fluid3D([17375,17222,17317,16897],0); -ELEMENTS[55083] = Fluid3D([17222,17317,16897,17333],0); -ELEMENTS[55084] = Fluid3D([17317,17375,16897,17301],0); -ELEMENTS[55085] = Fluid3D([10613,10292,10273,9715],0); -ELEMENTS[55086] = Fluid3D([10273,10613,9715,10400],0); -ELEMENTS[55087] = Fluid3D([10613,10292,9715,10383],0); -ELEMENTS[55088] = Fluid3D([2674,2507,2518,2803],0); -ELEMENTS[55089] = Fluid3D([16662,16521,17110,16849],0); -ELEMENTS[55090] = Fluid3D([14751,14268,14231,14906],0); -ELEMENTS[55091] = Fluid3D([14294,14184,14192,13647],0); -ELEMENTS[55092] = Fluid3D([18692,18674,18683,18648],0); -ELEMENTS[55093] = Fluid3D([17401,17543,17876,17624],0); -ELEMENTS[55094] = Fluid3D([17401,17543,17624,17224],0); -ELEMENTS[55095] = Fluid3D([17401,17543,17224,17045],0); -ELEMENTS[55096] = Fluid3D([9132,8592,9149,8764],0); -ELEMENTS[55097] = Fluid3D([8592,9149,8764,8044],0); -ELEMENTS[55098] = Fluid3D([9132,8592,8764,7852],0); -ELEMENTS[55099] = Fluid3D([8592,8764,7852,8044],0); -ELEMENTS[55100] = Fluid3D([10439,10453,9612,9954],0); -ELEMENTS[55101] = Fluid3D([9895,10556,10093,10014],0); -ELEMENTS[55102] = Fluid3D([2613,2677,2419,2343],0); -ELEMENTS[55103] = Fluid3D([5645,6100,6282,6206],0); -ELEMENTS[55104] = Fluid3D([15381,15345,15250,15730],0); -ELEMENTS[55105] = Fluid3D([15250,15381,15730,15346],0); -ELEMENTS[55106] = Fluid3D([15730,15250,15346,15054],0); -ELEMENTS[55107] = Fluid3D([15250,15346,15054,14850],0); -ELEMENTS[55108] = Fluid3D([15730,15250,15054,15774],0); -ELEMENTS[55109] = Fluid3D([15381,15730,15346,16084],0); -ELEMENTS[55110] = Fluid3D([8342,8811,8635,7815],0); -ELEMENTS[55111] = Fluid3D([8342,8811,7815,8170],0); -ELEMENTS[55112] = Fluid3D([4221,4183,4701,4610],0); -ELEMENTS[55113] = Fluid3D([9456,9045,8688,9903],0); -ELEMENTS[55114] = Fluid3D([7419,7390,6641,6832],0); -ELEMENTS[55115] = Fluid3D([6641,7419,6832,6667],0); -ELEMENTS[55116] = Fluid3D([6832,6641,6667,6386],0); -ELEMENTS[55117] = Fluid3D([6667,6832,6386,7757],0); -ELEMENTS[55118] = Fluid3D([7419,7390,6832,6982],0); -ELEMENTS[55119] = Fluid3D([6832,7419,6982,7757],0); -ELEMENTS[55120] = Fluid3D([6832,7419,7757,6667],0); -ELEMENTS[55121] = Fluid3D([6832,6641,6386,6140],0); -ELEMENTS[55122] = Fluid3D([6386,6832,6140,7244],0); -ELEMENTS[55123] = Fluid3D([13254,13143,13984,12974],0); -ELEMENTS[55124] = Fluid3D([17335,17019,16934,16880],0); -ELEMENTS[55125] = Fluid3D([17335,17019,16880,17066],0); -ELEMENTS[55126] = Fluid3D([12636,11658,12842,12172],0); -ELEMENTS[55127] = Fluid3D([18422,18294,18207,18274],0); -ELEMENTS[55128] = Fluid3D([12874,13452,13469,12991],0); -ELEMENTS[55129] = Fluid3D([7979,7497,8097,8347],0); -ELEMENTS[55130] = Fluid3D([10467,9469,9882,10818],0); -ELEMENTS[55131] = Fluid3D([5749,6612,6369,6232],0); -ELEMENTS[55132] = Fluid3D([6612,6369,6232,6967],0); -ELEMENTS[55133] = Fluid3D([5688,5175,5284,5909],0); -ELEMENTS[55134] = Fluid3D([5175,5284,5909,5393],0); -ELEMENTS[55135] = Fluid3D([5175,5284,5393,4896],0); -ELEMENTS[55136] = Fluid3D([5393,5175,4896,5643],0); -ELEMENTS[55137] = Fluid3D([10993,10724,10016,11483],0); -ELEMENTS[55138] = Fluid3D([9152,9752,8970,9131],0); -ELEMENTS[55139] = Fluid3D([9152,9752,9131,8487],0); -ELEMENTS[55140] = Fluid3D([13911,14483,13377,14273],0); -ELEMENTS[55141] = Fluid3D([13377,13911,14273,13853],0); -ELEMENTS[55142] = Fluid3D([13911,14273,13853,13904],0); -ELEMENTS[55143] = Fluid3D([13911,14273,13904,14619],0); -ELEMENTS[55144] = Fluid3D([13911,14483,14273,14619],0); -ELEMENTS[55145] = Fluid3D([13377,13911,13853,13523],0); -ELEMENTS[55146] = Fluid3D([13377,13911,13523,13889],0); -ELEMENTS[55147] = Fluid3D([13911,13853,13523,13904],0); -ELEMENTS[55148] = Fluid3D([13523,13911,13904,13889],0); -ELEMENTS[55149] = Fluid3D([13853,13523,13904,13945],0); -ELEMENTS[55150] = Fluid3D([13904,13523,13889,13124],0); -ELEMENTS[55151] = Fluid3D([13904,13523,13124,13151],0); -ELEMENTS[55152] = Fluid3D([13904,13523,13151,13945],0); -ELEMENTS[55153] = Fluid3D([14273,13853,13904,14797],0); -ELEMENTS[55154] = Fluid3D([14273,13853,14797,14357],0); -ELEMENTS[55155] = Fluid3D([14273,13853,14357,13541],0); -ELEMENTS[55156] = Fluid3D([13853,14357,13541,13945],0); -ELEMENTS[55157] = Fluid3D([14273,13853,13541,13238],0); -ELEMENTS[55158] = Fluid3D([13853,13541,13238,12930],0); -ELEMENTS[55159] = Fluid3D([13541,13238,12930,12277],0); -ELEMENTS[55160] = Fluid3D([13853,13541,12930,13945],0); -ELEMENTS[55161] = Fluid3D([13523,13124,13151,12835],0); -ELEMENTS[55162] = Fluid3D([13523,13124,12835,13377],0); -ELEMENTS[55163] = Fluid3D([12835,13523,13377,13853],0); -ELEMENTS[55164] = Fluid3D([13523,13889,13124,13377],0); -ELEMENTS[55165] = Fluid3D([14273,13377,13853,13238],0); -ELEMENTS[55166] = Fluid3D([13151,13523,12835,13853],0); -ELEMENTS[55167] = Fluid3D([13853,14357,13945,14797],0); -ELEMENTS[55168] = Fluid3D([13904,13911,14619,13889],0); -ELEMENTS[55169] = Fluid3D([13904,13853,13945,14797],0); -ELEMENTS[55170] = Fluid3D([13238,13853,12930,12835],0); -ELEMENTS[55171] = Fluid3D([13853,12930,12835,13151],0); -ELEMENTS[55172] = Fluid3D([12930,12835,13151,12521],0); -ELEMENTS[55173] = Fluid3D([12930,13238,12835,12121],0); -ELEMENTS[55174] = Fluid3D([12835,12930,12121,12521],0); -ELEMENTS[55175] = Fluid3D([12930,12121,12521,12277],0); -ELEMENTS[55176] = Fluid3D([12930,12121,12277,13238],0); -ELEMENTS[55177] = Fluid3D([14790,14961,14872,14023],0); -ELEMENTS[55178] = Fluid3D([7815,6957,7291,7413],0); -ELEMENTS[55179] = Fluid3D([6912,6728,6353,5744],0); -ELEMENTS[55180] = Fluid3D([12033,11935,12197,12925],0); -ELEMENTS[55181] = Fluid3D([11935,12197,12925,13087],0); -ELEMENTS[55182] = Fluid3D([12594,13004,12398,12156],0); -ELEMENTS[55183] = Fluid3D([6555,6601,5848,6965],0); -ELEMENTS[55184] = Fluid3D([6555,6601,6965,7478],0); -ELEMENTS[55185] = Fluid3D([16603,16874,17142,16444],0); -ELEMENTS[55186] = Fluid3D([7806,8205,8176,7848],0); -ELEMENTS[55187] = Fluid3D([17724,17674,17852,18102],0); -ELEMENTS[55188] = Fluid3D([12226,11565,12689,12538],0); -ELEMENTS[55189] = Fluid3D([12672,11944,11891,11652],0); -ELEMENTS[55190] = Fluid3D([2275,2171,2010,2083],0); -ELEMENTS[55191] = Fluid3D([2171,2010,2083,2152],0); -ELEMENTS[55192] = Fluid3D([2733,2634,2451,2911],0); -ELEMENTS[55193] = Fluid3D([12157,11246,11315,12181],0); -ELEMENTS[55194] = Fluid3D([18176,17971,18263,18201],0); -ELEMENTS[55195] = Fluid3D([18263,18176,18201,18455],0); -ELEMENTS[55196] = Fluid3D([18176,17971,18201,17961],0); -ELEMENTS[55197] = Fluid3D([18201,18176,17961,18322],0); -ELEMENTS[55198] = Fluid3D([18201,18176,18322,18455],0); -ELEMENTS[55199] = Fluid3D([13274,13546,12212,12996],0); -ELEMENTS[55200] = Fluid3D([13274,13546,12996,12993],0); -ELEMENTS[55201] = Fluid3D([13546,12212,12996,13765],0); -ELEMENTS[55202] = Fluid3D([13546,12996,12993,13844],0); -ELEMENTS[55203] = Fluid3D([14270,14372,14929,15149],0); -ELEMENTS[55204] = Fluid3D([13798,14190,13818,14996],0); -ELEMENTS[55205] = Fluid3D([17609,17454,17706,17825],0); -ELEMENTS[55206] = Fluid3D([2235,2448,2144,2346],0); -ELEMENTS[55207] = Fluid3D([12219,12695,12542,13233],0); -ELEMENTS[55208] = Fluid3D([5273,5490,4715,4924],0); -ELEMENTS[55209] = Fluid3D([13418,13479,14229,14115],0); -ELEMENTS[55210] = Fluid3D([11057,11800,11823,10372],0); -ELEMENTS[55211] = Fluid3D([15642,15257,15720,15703],0); -ELEMENTS[55212] = Fluid3D([8353,8550,7621,8190],0); -ELEMENTS[55213] = Fluid3D([8353,8550,8190,8649],0); -ELEMENTS[55214] = Fluid3D([8550,7621,8190,8799],0); -ELEMENTS[55215] = Fluid3D([8190,8550,8799,8649],0); -ELEMENTS[55216] = Fluid3D([8799,8190,8649,8209],0); -ELEMENTS[55217] = Fluid3D([8799,8190,8209,7621],0); -ELEMENTS[55218] = Fluid3D([8190,8649,8209,7543],0); -ELEMENTS[55219] = Fluid3D([8190,8649,7543,7880],0); -ELEMENTS[55220] = Fluid3D([8209,8190,7543,7621],0); -ELEMENTS[55221] = Fluid3D([8190,7543,7621,7189],0); -ELEMENTS[55222] = Fluid3D([8190,7543,7189,7880],0); -ELEMENTS[55223] = Fluid3D([7543,7621,7189,6821],0); -ELEMENTS[55224] = Fluid3D([12126,12073,12659,11783],0); -ELEMENTS[55225] = Fluid3D([17231,17516,17284,17235],0); -ELEMENTS[55226] = Fluid3D([9363,10158,9362,10800],0); -ELEMENTS[55227] = Fluid3D([5627,5194,5054,5679],0); -ELEMENTS[55228] = Fluid3D([14523,14195,14749,14141],0); -ELEMENTS[55229] = Fluid3D([14749,14523,14141,13691],0); -ELEMENTS[55230] = Fluid3D([14523,14195,14141,13691],0); -ELEMENTS[55231] = Fluid3D([15984,16074,16238,16674],0); -ELEMENTS[55232] = Fluid3D([18509,18440,18580,18527],0); -ELEMENTS[55233] = Fluid3D([18440,18580,18527,18426],0); -ELEMENTS[55234] = Fluid3D([18509,18440,18527,18410],0); -ELEMENTS[55235] = Fluid3D([18440,18527,18410,18314],0); -ELEMENTS[55236] = Fluid3D([18440,18527,18314,18426],0); -ELEMENTS[55237] = Fluid3D([18314,18440,18426,18415],0); -ELEMENTS[55238] = Fluid3D([3538,3659,3961,3966],0); -ELEMENTS[55239] = Fluid3D([17715,17341,17673,17419],0); -ELEMENTS[55240] = Fluid3D([18040,18016,18233,18162],0); -ELEMENTS[55241] = Fluid3D([18040,18016,18162,17968],0); -ELEMENTS[55242] = Fluid3D([18016,18233,18162,18337],0); -ELEMENTS[55243] = Fluid3D([9275,9237,9981,9056],0); -ELEMENTS[55244] = Fluid3D([8663,7952,8813,7981],0); -ELEMENTS[55245] = Fluid3D([8906,9883,9380,10139],0); -ELEMENTS[55246] = Fluid3D([9380,8906,10139,9233],0); -ELEMENTS[55247] = Fluid3D([9380,8906,9233,8508],0); -ELEMENTS[55248] = Fluid3D([9380,8906,8508,8662],0); -ELEMENTS[55249] = Fluid3D([8906,9233,8508,8390],0); -ELEMENTS[55250] = Fluid3D([6749,7538,7457,6618],0); -ELEMENTS[55251] = Fluid3D([7457,6749,6618,7181],0); -ELEMENTS[55252] = Fluid3D([8910,8459,9129,9756],0); -ELEMENTS[55253] = Fluid3D([7943,7594,7607,6967],0); -ELEMENTS[55254] = Fluid3D([7607,7943,6967,7755],0); -ELEMENTS[55255] = Fluid3D([7607,7943,7755,8432],0); -ELEMENTS[55256] = Fluid3D([17065,16761,16800,16849],0); -ELEMENTS[55257] = Fluid3D([6980,7869,7863,6959],0); -ELEMENTS[55258] = Fluid3D([7869,7863,6959,7693],0); -ELEMENTS[55259] = Fluid3D([7869,7863,7693,8627],0); -ELEMENTS[55260] = Fluid3D([7869,7863,8627,8847],0); -ELEMENTS[55261] = Fluid3D([4104,3730,4269,3916],0); -ELEMENTS[55262] = Fluid3D([11392,11892,12112,12696],0); -ELEMENTS[55263] = Fluid3D([2441,2648,2338,2639],0); -ELEMENTS[55264] = Fluid3D([13769,14639,13578,13999],0); -ELEMENTS[55265] = Fluid3D([3168,3216,3245,2943],0); -ELEMENTS[55266] = Fluid3D([13902,14442,14605,14166],0); -ELEMENTS[55267] = Fluid3D([12924,13307,13087,13774],0); -ELEMENTS[55268] = Fluid3D([6247,5907,6655,6572],0); -ELEMENTS[55269] = Fluid3D([14179,13672,14281,14547],0); -ELEMENTS[55270] = Fluid3D([6789,7628,6892,6949],0); -ELEMENTS[55271] = Fluid3D([17790,17882,17968,17610],0); -ELEMENTS[55272] = Fluid3D([17882,17968,17610,17886],0); -ELEMENTS[55273] = Fluid3D([17882,17968,17886,18105],0); -ELEMENTS[55274] = Fluid3D([17886,17882,18105,18033],0); -ELEMENTS[55275] = Fluid3D([17882,17968,18105,18035],0); -ELEMENTS[55276] = Fluid3D([18105,17882,18035,17975],0); -ELEMENTS[55277] = Fluid3D([17790,17882,17610,17399],0); -ELEMENTS[55278] = Fluid3D([17610,17882,17886,17609],0); -ELEMENTS[55279] = Fluid3D([17882,17886,17609,18033],0); -ELEMENTS[55280] = Fluid3D([17610,17882,17609,17399],0); -ELEMENTS[55281] = Fluid3D([17609,17610,17399,17339],0); -ELEMENTS[55282] = Fluid3D([17610,17399,17339,17416],0); -ELEMENTS[55283] = Fluid3D([17886,17610,17609,17639],0); -ELEMENTS[55284] = Fluid3D([17609,17610,17339,17639],0); -ELEMENTS[55285] = Fluid3D([17339,17610,17416,17754],0); -ELEMENTS[55286] = Fluid3D([18105,17882,17975,18033],0); -ELEMENTS[55287] = Fluid3D([9857,9417,10109,8721],0); -ELEMENTS[55288] = Fluid3D([6611,7057,7307,7820],0); -ELEMENTS[55289] = Fluid3D([14574,15167,15121,15033],0); -ELEMENTS[55290] = Fluid3D([15167,15121,15033,15757],0); -ELEMENTS[55291] = Fluid3D([15167,15121,15757,15954],0); -ELEMENTS[55292] = Fluid3D([4028,3768,3640,3652],0); -ELEMENTS[55293] = Fluid3D([3640,4028,3652,3426],0); -ELEMENTS[55294] = Fluid3D([3652,3640,3426,3191],0); -ELEMENTS[55295] = Fluid3D([3426,3652,3191,3386],0); -ELEMENTS[55296] = Fluid3D([3426,3652,3386,3682],0); -ELEMENTS[55297] = Fluid3D([3426,3652,3682,4028],0); -ELEMENTS[55298] = Fluid3D([3652,3682,4028,4337],0); -ELEMENTS[55299] = Fluid3D([3652,3386,3682,4025],0); -ELEMENTS[55300] = Fluid3D([3652,3191,3386,3768],0); -ELEMENTS[55301] = Fluid3D([3640,3426,3191,3229],0); -ELEMENTS[55302] = Fluid3D([3768,3640,3652,3191],0); -ELEMENTS[55303] = Fluid3D([3682,3652,4025,4337],0); -ELEMENTS[55304] = Fluid3D([6542,7191,6574,7453],0); -ELEMENTS[55305] = Fluid3D([7191,6574,7453,7269],0); -ELEMENTS[55306] = Fluid3D([8833,9483,8739,8927],0); -ELEMENTS[55307] = Fluid3D([8833,9483,8927,9822],0); -ELEMENTS[55308] = Fluid3D([4134,3959,3632,3930],0); -ELEMENTS[55309] = Fluid3D([14546,15043,14224,14310],0); -ELEMENTS[55310] = Fluid3D([15043,14224,14310,14905],0); -ELEMENTS[55311] = Fluid3D([4312,4622,3995,4348],0); -ELEMENTS[55312] = Fluid3D([6194,6046,6442,5604],0); -ELEMENTS[55313] = Fluid3D([6046,6442,5604,6226],0); -ELEMENTS[55314] = Fluid3D([6046,6442,6226,6765],0); -ELEMENTS[55315] = Fluid3D([6442,5604,6226,5795],0); -ELEMENTS[55316] = Fluid3D([6442,6226,6765,7285],0); -ELEMENTS[55317] = Fluid3D([17261,17289,17645,17560],0); -ELEMENTS[55318] = Fluid3D([18177,18074,18138,18108],0); -ELEMENTS[55319] = Fluid3D([18177,18074,18108,17692],0); -ELEMENTS[55320] = Fluid3D([9224,8682,8367,8623],0); -ELEMENTS[55321] = Fluid3D([1715,1808,1829,1729],0); -ELEMENTS[55322] = Fluid3D([1715,1808,1729,1639],0); -ELEMENTS[55323] = Fluid3D([1808,1829,1729,1849],0); -ELEMENTS[55324] = Fluid3D([14455,14747,14655,13860],0); -ELEMENTS[55325] = Fluid3D([17870,17571,17630,17642],0); -ELEMENTS[55326] = Fluid3D([17870,17571,17642,17871],0); -ELEMENTS[55327] = Fluid3D([17571,17642,17871,17356],0); -ELEMENTS[55328] = Fluid3D([17571,17630,17642,17048],0); -ELEMENTS[55329] = Fluid3D([7352,7357,6829,6608],0); -ELEMENTS[55330] = Fluid3D([18029,17944,17786,17802],0); -ELEMENTS[55331] = Fluid3D([9465,8907,9816,9908],0); -ELEMENTS[55332] = Fluid3D([8907,9816,9908,9089],0); -ELEMENTS[55333] = Fluid3D([15473,15131,14779,15387],0); -ELEMENTS[55334] = Fluid3D([3421,3511,3156,3488],0); -ELEMENTS[55335] = Fluid3D([3156,3421,3488,3688],0); -ELEMENTS[55336] = Fluid3D([3421,3488,3688,3511],0); -ELEMENTS[55337] = Fluid3D([7819,7795,8691,7847],0); -ELEMENTS[55338] = Fluid3D([7819,7795,7847,7028],0); -ELEMENTS[55339] = Fluid3D([7795,8691,7847,7781],0); -ELEMENTS[55340] = Fluid3D([7847,7795,7781,7028],0); -ELEMENTS[55341] = Fluid3D([7781,7847,7028,7382],0); -ELEMENTS[55342] = Fluid3D([7847,7028,7382,7819],0); -ELEMENTS[55343] = Fluid3D([7382,7847,7819,8714],0); -ELEMENTS[55344] = Fluid3D([7781,7847,7382,8244],0); -ELEMENTS[55345] = Fluid3D([7847,7382,8244,8714],0); -ELEMENTS[55346] = Fluid3D([8244,7847,8714,8695],0); -ELEMENTS[55347] = Fluid3D([8244,7847,8695,7781],0); -ELEMENTS[55348] = Fluid3D([7847,8695,7781,8691],0); -ELEMENTS[55349] = Fluid3D([7847,8695,8691,8714],0); -ELEMENTS[55350] = Fluid3D([8695,8691,8714,9645],0); -ELEMENTS[55351] = Fluid3D([8691,7847,8714,7819],0); -ELEMENTS[55352] = Fluid3D([8714,8244,8695,9645],0); -ELEMENTS[55353] = Fluid3D([8714,8691,7819,8718],0); -ELEMENTS[55354] = Fluid3D([8714,8691,8718,9634],0); -ELEMENTS[55355] = Fluid3D([8714,8691,9634,9645],0); -ELEMENTS[55356] = Fluid3D([7795,7781,7028,7263],0); -ELEMENTS[55357] = Fluid3D([3875,3458,4087,3958],0); -ELEMENTS[55358] = Fluid3D([14170,14434,14193,13473],0); -ELEMENTS[55359] = Fluid3D([4900,4379,4561,4255],0); -ELEMENTS[55360] = Fluid3D([17670,17978,18067,17875],0); -ELEMENTS[55361] = Fluid3D([17978,18067,17875,18276],0); -ELEMENTS[55362] = Fluid3D([13888,13250,14401,14117],0); -ELEMENTS[55363] = Fluid3D([3678,3603,3637,3932],0); -ELEMENTS[55364] = Fluid3D([3637,3678,3932,3884],0); -ELEMENTS[55365] = Fluid3D([3932,3637,3884,4060],0); -ELEMENTS[55366] = Fluid3D([3932,3637,4060,3818],0); -ELEMENTS[55367] = Fluid3D([3603,3637,3932,3818],0); -ELEMENTS[55368] = Fluid3D([3678,3603,3932,4185],0); -ELEMENTS[55369] = Fluid3D([3884,3932,4060,4477],0); -ELEMENTS[55370] = Fluid3D([11998,12543,12174,11108],0); -ELEMENTS[55371] = Fluid3D([15306,15093,15667,15974],0); -ELEMENTS[55372] = Fluid3D([12097,11888,12367,11300],0); -ELEMENTS[55373] = Fluid3D([13224,13986,13358,12772],0); -ELEMENTS[55374] = Fluid3D([13358,13224,12772,12419],0); -ELEMENTS[55375] = Fluid3D([12886,13019,13322,12643],0); -ELEMENTS[55376] = Fluid3D([5410,5453,5200,5691],0); -ELEMENTS[55377] = Fluid3D([5200,5410,5691,5781],0); -ELEMENTS[55378] = Fluid3D([5410,5691,5781,6297],0); -ELEMENTS[55379] = Fluid3D([5410,5453,5691,6297],0); -ELEMENTS[55380] = Fluid3D([5691,5200,5781,5797],0); -ELEMENTS[55381] = Fluid3D([5691,5200,5797,5453],0); -ELEMENTS[55382] = Fluid3D([5781,5691,5797,6161],0); -ELEMENTS[55383] = Fluid3D([5691,5797,6161,5453],0); -ELEMENTS[55384] = Fluid3D([5781,5691,6161,6297],0); -ELEMENTS[55385] = Fluid3D([5691,6161,6297,5453],0); -ELEMENTS[55386] = Fluid3D([3371,3608,3614,3773],0); -ELEMENTS[55387] = Fluid3D([7496,7634,7418,8379],0); -ELEMENTS[55388] = Fluid3D([8030,7909,8304,8871],0); -ELEMENTS[55389] = Fluid3D([13465,13669,13248,12690],0); -ELEMENTS[55390] = Fluid3D([3089,3092,3549,3286],0); -ELEMENTS[55391] = Fluid3D([5457,5642,5998,5758],0); -ELEMENTS[55392] = Fluid3D([14656,15358,14815,14882],0); -ELEMENTS[55393] = Fluid3D([15358,14815,14882,15780],0); -ELEMENTS[55394] = Fluid3D([15057,15375,15799,15551],0); -ELEMENTS[55395] = Fluid3D([18535,18516,18478,18593],0); -ELEMENTS[55396] = Fluid3D([18535,18516,18593,18613],0); -ELEMENTS[55397] = Fluid3D([12299,13191,12901,13299],0); -ELEMENTS[55398] = Fluid3D([12299,13191,13299,12810],0); -ELEMENTS[55399] = Fluid3D([12299,13191,12810,11812],0); -ELEMENTS[55400] = Fluid3D([5468,5557,6076,5614],0); -ELEMENTS[55401] = Fluid3D([5557,6076,5614,6259],0); -ELEMENTS[55402] = Fluid3D([2618,2673,2598,2380],0); -ELEMENTS[55403] = Fluid3D([2598,2618,2380,2401],0); -ELEMENTS[55404] = Fluid3D([2673,2598,2380,2272],0); -ELEMENTS[55405] = Fluid3D([14272,14595,13891,13382],0); -ELEMENTS[55406] = Fluid3D([14889,14553,15028,15330],0); -ELEMENTS[55407] = Fluid3D([14889,14553,15330,15206],0); -ELEMENTS[55408] = Fluid3D([14889,14553,15206,14768],0); -ELEMENTS[55409] = Fluid3D([17329,16864,17212,17475],0); -ELEMENTS[55410] = Fluid3D([14962,15221,15625,15840],0); -ELEMENTS[55411] = Fluid3D([10160,10158,10800,9362],0); -ELEMENTS[55412] = Fluid3D([16816,16957,16605,16523],0); -ELEMENTS[55413] = Fluid3D([6029,5935,5784,6492],0); -ELEMENTS[55414] = Fluid3D([14192,14671,13639,13708],0); -ELEMENTS[55415] = Fluid3D([14192,14671,13708,14416],0); -ELEMENTS[55416] = Fluid3D([14192,14671,14416,14641],0); -ELEMENTS[55417] = Fluid3D([14192,14671,14641,15216],0); -ELEMENTS[55418] = Fluid3D([15184,14389,14839,14956],0); -ELEMENTS[55419] = Fluid3D([14467,15202,14789,15179],0); -ELEMENTS[55420] = Fluid3D([8575,9434,9648,9075],0); -ELEMENTS[55421] = Fluid3D([13210,13244,13947,14194],0); -ELEMENTS[55422] = Fluid3D([8479,8458,8566,7820],0); -ELEMENTS[55423] = Fluid3D([8458,8566,7820,7706],0); -ELEMENTS[55424] = Fluid3D([11682,11234,11947,11866],0); -ELEMENTS[55425] = Fluid3D([7837,8757,7508,8368],0); -ELEMENTS[55426] = Fluid3D([14867,15474,14564,14868],0); -ELEMENTS[55427] = Fluid3D([12605,11824,11795,12240],0); -ELEMENTS[55428] = Fluid3D([13749,13371,13952,14028],0); -ELEMENTS[55429] = Fluid3D([13749,13371,14028,13750],0); -ELEMENTS[55430] = Fluid3D([10022,10550,9443,9567],0); -ELEMENTS[55431] = Fluid3D([11188,11559,10454,10370],0); -ELEMENTS[55432] = Fluid3D([10454,11188,10370,10055],0); -ELEMENTS[55433] = Fluid3D([11559,10454,10370,11098],0); -ELEMENTS[55434] = Fluid3D([11559,10454,11098,11460],0); -ELEMENTS[55435] = Fluid3D([10361,10699,11070,9809],0); -ELEMENTS[55436] = Fluid3D([9298,10004,10010,9761],0); -ELEMENTS[55437] = Fluid3D([10004,10010,9761,10666],0); -ELEMENTS[55438] = Fluid3D([16338,15825,16198,15683],0); -ELEMENTS[55439] = Fluid3D([6298,5842,5704,6163],0); -ELEMENTS[55440] = Fluid3D([18205,18153,18099,17938],0); -ELEMENTS[55441] = Fluid3D([10206,9484,10402,9942],0); -ELEMENTS[55442] = Fluid3D([10402,10206,9942,10705],0); -ELEMENTS[55443] = Fluid3D([10206,9484,9942,9234],0); -ELEMENTS[55444] = Fluid3D([9942,10206,9234,9899],0); -ELEMENTS[55445] = Fluid3D([9942,10206,9899,11082],0); -ELEMENTS[55446] = Fluid3D([9234,9942,9899,9322],0); -ELEMENTS[55447] = Fluid3D([9942,9899,9322,9788],0); -ELEMENTS[55448] = Fluid3D([9234,9942,9322,9317],0); -ELEMENTS[55449] = Fluid3D([9899,9322,9788,9498],0); -ELEMENTS[55450] = Fluid3D([9899,9322,9498,9234],0); -ELEMENTS[55451] = Fluid3D([9498,9899,9234,10206],0); -ELEMENTS[55452] = Fluid3D([9498,9899,10206,10706],0); -ELEMENTS[55453] = Fluid3D([9942,9899,9788,10705],0); -ELEMENTS[55454] = Fluid3D([9942,9322,9317,9788],0); -ELEMENTS[55455] = Fluid3D([9788,9899,9498,9896],0); -ELEMENTS[55456] = Fluid3D([9899,9498,9896,10706],0); -ELEMENTS[55457] = Fluid3D([10206,9484,9234,9271],0); -ELEMENTS[55458] = Fluid3D([9322,9498,9234,8546],0); -ELEMENTS[55459] = Fluid3D([9498,9234,8546,10206],0); -ELEMENTS[55460] = Fluid3D([9234,9322,8546,8864],0); -ELEMENTS[55461] = Fluid3D([8546,9234,8864,8704],0); -ELEMENTS[55462] = Fluid3D([9234,9322,8864,9317],0); -ELEMENTS[55463] = Fluid3D([8546,9234,8704,9484],0); -ELEMENTS[55464] = Fluid3D([9234,8864,8704,9484],0); -ELEMENTS[55465] = Fluid3D([9234,8546,10206,9271],0); -ELEMENTS[55466] = Fluid3D([9234,8546,9271,9484],0); -ELEMENTS[55467] = Fluid3D([8864,8546,8704,8462],0); -ELEMENTS[55468] = Fluid3D([8864,8546,8462,8958],0); -ELEMENTS[55469] = Fluid3D([8462,8864,8958,8998],0); -ELEMENTS[55470] = Fluid3D([8462,8864,8998,9317],0); -ELEMENTS[55471] = Fluid3D([8704,8864,8462,8791],0); -ELEMENTS[55472] = Fluid3D([8864,8546,8958,9322],0); -ELEMENTS[55473] = Fluid3D([8958,8864,9322,8998],0); -ELEMENTS[55474] = Fluid3D([9322,8958,8998,8536],0); -ELEMENTS[55475] = Fluid3D([9322,8958,8536,9073],0); -ELEMENTS[55476] = Fluid3D([8998,9322,8536,9788],0); -ELEMENTS[55477] = Fluid3D([8958,8998,8536,8462],0); -ELEMENTS[55478] = Fluid3D([8536,8958,8462,8546],0); -ELEMENTS[55479] = Fluid3D([8864,9322,8998,9317],0); -ELEMENTS[55480] = Fluid3D([9322,8998,9317,9788],0); -ELEMENTS[55481] = Fluid3D([8958,8536,9073,8176],0); -ELEMENTS[55482] = Fluid3D([8958,8536,8176,8546],0); -ELEMENTS[55483] = Fluid3D([8546,8958,9322,9498],0); -ELEMENTS[55484] = Fluid3D([8958,9322,9498,9073],0); -ELEMENTS[55485] = Fluid3D([8462,8864,9317,8671],0); -ELEMENTS[55486] = Fluid3D([8462,8864,8671,8791],0); -ELEMENTS[55487] = Fluid3D([8176,8958,8546,9498],0); -ELEMENTS[55488] = Fluid3D([9498,8958,9073,8176],0); -ELEMENTS[55489] = Fluid3D([8864,9317,8671,9484],0); -ELEMENTS[55490] = Fluid3D([9942,9899,10705,11082],0); -ELEMENTS[55491] = Fluid3D([8704,8864,8791,9484],0); -ELEMENTS[55492] = Fluid3D([8791,8704,9484,9456],0); -ELEMENTS[55493] = Fluid3D([8864,9234,9317,9484],0); -ELEMENTS[55494] = Fluid3D([3172,3201,3473,3281],0); -ELEMENTS[55495] = Fluid3D([3172,3201,3281,2952],0); -ELEMENTS[55496] = Fluid3D([5743,5463,5091,5100],0); -ELEMENTS[55497] = Fluid3D([5743,5463,5100,5623],0); -ELEMENTS[55498] = Fluid3D([5743,5463,5623,5713],0); -ELEMENTS[55499] = Fluid3D([5100,5743,5623,5726],0); -ELEMENTS[55500] = Fluid3D([5463,5100,5623,5143],0); -ELEMENTS[55501] = Fluid3D([8844,8222,9169,8740],0); -ELEMENTS[55502] = Fluid3D([9169,8844,8740,9787],0); -ELEMENTS[55503] = Fluid3D([14227,13330,13735,13966],0); -ELEMENTS[55504] = Fluid3D([13735,14227,13966,14767],0); -ELEMENTS[55505] = Fluid3D([13330,13735,13966,13710],0); -ELEMENTS[55506] = Fluid3D([14227,13330,13966,14045],0); -ELEMENTS[55507] = Fluid3D([13330,13966,14045,13710],0); -ELEMENTS[55508] = Fluid3D([13966,14045,13710,14364],0); -ELEMENTS[55509] = Fluid3D([13966,14045,14364,14767],0); -ELEMENTS[55510] = Fluid3D([14364,13966,14767,13735],0); -ELEMENTS[55511] = Fluid3D([13710,13966,14364,13984],0); -ELEMENTS[55512] = Fluid3D([13966,14364,13984,13735],0); -ELEMENTS[55513] = Fluid3D([1870,1739,1836,1919],0); -ELEMENTS[55514] = Fluid3D([13367,13159,14073,13023],0); -ELEMENTS[55515] = Fluid3D([13367,13159,13023,12380],0); -ELEMENTS[55516] = Fluid3D([10858,11682,11735,10747],0); -ELEMENTS[55517] = Fluid3D([11682,11735,10747,10591],0); -ELEMENTS[55518] = Fluid3D([12281,13165,12165,12968],0); -ELEMENTS[55519] = Fluid3D([9529,9481,10119,10789],0); -ELEMENTS[55520] = Fluid3D([8189,7456,7542,8671],0); -ELEMENTS[55521] = Fluid3D([2185,2223,1997,2141],0); -ELEMENTS[55522] = Fluid3D([2185,2223,2141,2485],0); -ELEMENTS[55523] = Fluid3D([2223,1997,2141,2018],0); -ELEMENTS[55524] = Fluid3D([1997,2185,2141,2007],0); -ELEMENTS[55525] = Fluid3D([2185,2141,2007,2198],0); -ELEMENTS[55526] = Fluid3D([2185,2141,2198,2485],0); -ELEMENTS[55527] = Fluid3D([2141,2007,2198,1960],0); -ELEMENTS[55528] = Fluid3D([2007,2185,2198,2098],0); -ELEMENTS[55529] = Fluid3D([2141,2007,1960,1997],0); -ELEMENTS[55530] = Fluid3D([2198,2007,2098,2056],0); -ELEMENTS[55531] = Fluid3D([1997,2185,2007,1956],0); -ELEMENTS[55532] = Fluid3D([2185,2198,2098,2292],0); -ELEMENTS[55533] = Fluid3D([2198,2098,2292,2056],0); -ELEMENTS[55534] = Fluid3D([2185,2198,2292,2485],0); -ELEMENTS[55535] = Fluid3D([2292,2198,2056,2163],0); -ELEMENTS[55536] = Fluid3D([2007,2198,1960,1942],0); -ELEMENTS[55537] = Fluid3D([2920,2606,2927,2715],0); -ELEMENTS[55538] = Fluid3D([17073,16646,16802,16709],0); -ELEMENTS[55539] = Fluid3D([16646,16802,16709,16197],0); -ELEMENTS[55540] = Fluid3D([18631,18566,18633,18590],0); -ELEMENTS[55541] = Fluid3D([18631,18566,18590,18501],0); -ELEMENTS[55542] = Fluid3D([5166,4765,5409,5612],0); -ELEMENTS[55543] = Fluid3D([5166,4765,5612,5105],0); -ELEMENTS[55544] = Fluid3D([17443,17432,17747,17244],0); -ELEMENTS[55545] = Fluid3D([12904,11883,12747,11968],0); -ELEMENTS[55546] = Fluid3D([16885,16803,17308,17259],0); -ELEMENTS[55547] = Fluid3D([16252,15942,15622,15473],0); -ELEMENTS[55548] = Fluid3D([2976,3212,2911,3117],0); -ELEMENTS[55549] = Fluid3D([9645,10036,10626,9692],0); -ELEMENTS[55550] = Fluid3D([14148,14843,14674,14270],0); -ELEMENTS[55551] = Fluid3D([9041,8076,8807,8759],0); -ELEMENTS[55552] = Fluid3D([8807,9041,8759,9811],0); -ELEMENTS[55553] = Fluid3D([8076,8807,8759,8756],0); -ELEMENTS[55554] = Fluid3D([18166,18391,18380,18333],0); -ELEMENTS[55555] = Fluid3D([9024,8219,8852,8098],0); -ELEMENTS[55556] = Fluid3D([9024,8219,8098,8329],0); -ELEMENTS[55557] = Fluid3D([8219,8098,8329,7447],0); -ELEMENTS[55558] = Fluid3D([8098,9024,8329,9102],0); -ELEMENTS[55559] = Fluid3D([8098,8329,7447,8193],0); -ELEMENTS[55560] = Fluid3D([8098,8329,8193,9102],0); -ELEMENTS[55561] = Fluid3D([6568,6944,5953,6419],0); -ELEMENTS[55562] = Fluid3D([15593,15857,16261,15575],0); -ELEMENTS[55563] = Fluid3D([15593,15857,15575,14992],0); -ELEMENTS[55564] = Fluid3D([15857,16261,15575,16027],0); -ELEMENTS[55565] = Fluid3D([15575,15857,16027,15607],0); -ELEMENTS[55566] = Fluid3D([5423,5317,4983,5313],0); -ELEMENTS[55567] = Fluid3D([5317,4983,5313,5754],0); -ELEMENTS[55568] = Fluid3D([5317,4983,5754,5215],0); -ELEMENTS[55569] = Fluid3D([5317,4983,5215,4641],0); -ELEMENTS[55570] = Fluid3D([5754,5317,5215,5796],0); -ELEMENTS[55571] = Fluid3D([5317,5215,5796,5121],0); -ELEMENTS[55572] = Fluid3D([5215,5317,4641,5121],0); -ELEMENTS[55573] = Fluid3D([5870,5509,6131,5188],0); -ELEMENTS[55574] = Fluid3D([4090,4452,4620,3957],0); -ELEMENTS[55575] = Fluid3D([9815,9753,9372,8689],0); -ELEMENTS[55576] = Fluid3D([9372,9815,8689,8492],0); -ELEMENTS[55577] = Fluid3D([11895,11243,10720,11474],0); -ELEMENTS[55578] = Fluid3D([8720,8867,9612,8729],0); -ELEMENTS[55579] = Fluid3D([9381,10459,9495,9678],0); -ELEMENTS[55580] = Fluid3D([7365,8136,7712,8475],0); -ELEMENTS[55581] = Fluid3D([17977,17715,18113,17915],0); -ELEMENTS[55582] = Fluid3D([14429,14166,14928,14792],0); -ELEMENTS[55583] = Fluid3D([6777,7587,7268,7561],0); -ELEMENTS[55584] = Fluid3D([12367,12984,12212,12302],0); -ELEMENTS[55585] = Fluid3D([3438,3196,3423,3779],0); -ELEMENTS[55586] = Fluid3D([14701,13868,14004,13509],0); -ELEMENTS[55587] = Fluid3D([14100,14590,15040,13910],0); -ELEMENTS[55588] = Fluid3D([6218,5675,6393,5719],0); -ELEMENTS[55589] = Fluid3D([10049,9312,10363,10524],0); -ELEMENTS[55590] = Fluid3D([11023,10728,10319,10797],0); -ELEMENTS[55591] = Fluid3D([5463,5377,5091,4666],0); -ELEMENTS[55592] = Fluid3D([13121,13708,13225,12507],0); -ELEMENTS[55593] = Fluid3D([18408,18267,18483,18393],0); -ELEMENTS[55594] = Fluid3D([3126,3139,3339,3504],0); -ELEMENTS[55595] = Fluid3D([3126,3139,3504,3068],0); -ELEMENTS[55596] = Fluid3D([3126,3139,3068,2811],0); -ELEMENTS[55597] = Fluid3D([5488,5532,5485,6130],0); -ELEMENTS[55598] = Fluid3D([4560,5125,4985,4478],0); -ELEMENTS[55599] = Fluid3D([12275,11840,12333,12732],0); -ELEMENTS[55600] = Fluid3D([11840,12333,12732,12331],0); -ELEMENTS[55601] = Fluid3D([12275,11840,12732,12331],0); -ELEMENTS[55602] = Fluid3D([9457,8995,9090,9139],0); -ELEMENTS[55603] = Fluid3D([2686,2539,2314,2431],0); -ELEMENTS[55604] = Fluid3D([13081,13763,13957,13288],0); -ELEMENTS[55605] = Fluid3D([13483,13403,13038,12448],0); -ELEMENTS[55606] = Fluid3D([4143,4545,4039,4543],0); -ELEMENTS[55607] = Fluid3D([7842,8635,8811,7815],0); -ELEMENTS[55608] = Fluid3D([10363,10324,10018,9205],0); -ELEMENTS[55609] = Fluid3D([5130,5713,5239,5093],0); -ELEMENTS[55610] = Fluid3D([4761,5165,4624,4450],0); -ELEMENTS[55611] = Fluid3D([4624,4761,4450,4378],0); -ELEMENTS[55612] = Fluid3D([4624,4761,4378,4637],0); -ELEMENTS[55613] = Fluid3D([4761,4378,4637,4324],0); -ELEMENTS[55614] = Fluid3D([17262,16948,17169,16966],0); -ELEMENTS[55615] = Fluid3D([17262,16948,16966,17072],0); -ELEMENTS[55616] = Fluid3D([17262,16948,17072,17382],0); -ELEMENTS[55617] = Fluid3D([17262,16948,17382,17301],0); -ELEMENTS[55618] = Fluid3D([9443,9191,9255,8770],0); -ELEMENTS[55619] = Fluid3D([11578,11070,10699,10601],0); -ELEMENTS[55620] = Fluid3D([11578,11070,10601,10977],0); -ELEMENTS[55621] = Fluid3D([11070,10601,10977,9809],0); -ELEMENTS[55622] = Fluid3D([10601,10977,9809,10401],0); -ELEMENTS[55623] = Fluid3D([10601,10977,10401,11687],0); -ELEMENTS[55624] = Fluid3D([10601,11578,10977,11687],0); -ELEMENTS[55625] = Fluid3D([10601,11578,11687,10699],0); -ELEMENTS[55626] = Fluid3D([11070,10699,10601,9809],0); -ELEMENTS[55627] = Fluid3D([11578,11687,10699,11601],0); -ELEMENTS[55628] = Fluid3D([5309,4955,4977,5139],0); -ELEMENTS[55629] = Fluid3D([16282,16664,16522,16853],0); -ELEMENTS[55630] = Fluid3D([16282,16664,16853,16615],0); -ELEMENTS[55631] = Fluid3D([16664,16853,16615,17082],0); -ELEMENTS[55632] = Fluid3D([16853,16282,16615,16520],0); -ELEMENTS[55633] = Fluid3D([16853,16282,16520,16522],0); -ELEMENTS[55634] = Fluid3D([16615,16853,16520,16614],0); -ELEMENTS[55635] = Fluid3D([16520,16615,16614,16282],0); -ELEMENTS[55636] = Fluid3D([16615,16614,16282,16604],0); -ELEMENTS[55637] = Fluid3D([16615,16614,16604,17004],0); -ELEMENTS[55638] = Fluid3D([16604,16615,17004,16664],0); -ELEMENTS[55639] = Fluid3D([16604,16615,16664,16282],0); -ELEMENTS[55640] = Fluid3D([16615,16853,16614,17082],0); -ELEMENTS[55641] = Fluid3D([16614,16615,17082,17004],0); -ELEMENTS[55642] = Fluid3D([16615,17082,17004,16664],0); -ELEMENTS[55643] = Fluid3D([16853,16520,16614,17066],0); -ELEMENTS[55644] = Fluid3D([16853,16520,17066,16999],0); -ELEMENTS[55645] = Fluid3D([17066,16853,16999,17041],0); -ELEMENTS[55646] = Fluid3D([16853,16520,16999,16506],0); -ELEMENTS[55647] = Fluid3D([17066,16853,17041,17173],0); -ELEMENTS[55648] = Fluid3D([16520,17066,16999,16880],0); -ELEMENTS[55649] = Fluid3D([16853,16999,17041,16522],0); -ELEMENTS[55650] = Fluid3D([16853,16520,16506,16522],0); -ELEMENTS[55651] = Fluid3D([16999,16853,16506,16522],0); -ELEMENTS[55652] = Fluid3D([16999,17066,17041,17348],0); -ELEMENTS[55653] = Fluid3D([17066,16999,16880,17349],0); -ELEMENTS[55654] = Fluid3D([17066,16999,17349,17348],0); -ELEMENTS[55655] = Fluid3D([17041,16853,16522,16664],0); -ELEMENTS[55656] = Fluid3D([17041,16853,16664,17173],0); -ELEMENTS[55657] = Fluid3D([16520,16999,16506,16880],0); -ELEMENTS[55658] = Fluid3D([16999,17349,17348,16782],0); -ELEMENTS[55659] = Fluid3D([15876,15453,15848,15367],0); -ELEMENTS[55660] = Fluid3D([15876,15453,15367,14969],0); -ELEMENTS[55661] = Fluid3D([15453,15367,14969,14892],0); -ELEMENTS[55662] = Fluid3D([15367,15876,14969,15643],0); -ELEMENTS[55663] = Fluid3D([15453,15848,15367,14892],0); -ELEMENTS[55664] = Fluid3D([15848,15876,15367,15893],0); -ELEMENTS[55665] = Fluid3D([15876,15367,15893,15643],0); -ELEMENTS[55666] = Fluid3D([15848,15876,15893,16436],0); -ELEMENTS[55667] = Fluid3D([16143,16378,16341,15921],0); -ELEMENTS[55668] = Fluid3D([9213,9247,8428,8305],0); -ELEMENTS[55669] = Fluid3D([6151,6015,5527,6331],0); -ELEMENTS[55670] = Fluid3D([6151,6015,6331,6680],0); -ELEMENTS[55671] = Fluid3D([13474,12531,12672,11983],0); -ELEMENTS[55672] = Fluid3D([8032,7146,7594,7274],0); -ELEMENTS[55673] = Fluid3D([6987,6316,6362,5783],0); -ELEMENTS[55674] = Fluid3D([4840,5250,5053,5572],0); -ELEMENTS[55675] = Fluid3D([14633,13989,14012,14516],0); -ELEMENTS[55676] = Fluid3D([6132,5673,6446,6370],0); -ELEMENTS[55677] = Fluid3D([2495,2381,2749,2517],0); -ELEMENTS[55678] = Fluid3D([5346,5256,4957,5542],0); -ELEMENTS[55679] = Fluid3D([2805,2840,3095,3112],0); -ELEMENTS[55680] = Fluid3D([2840,3095,3112,3381],0); -ELEMENTS[55681] = Fluid3D([4860,5443,4851,4690],0); -ELEMENTS[55682] = Fluid3D([6244,5881,5917,5546],0); -ELEMENTS[55683] = Fluid3D([18593,18586,18478,18535],0); -ELEMENTS[55684] = Fluid3D([18593,18586,18535,18638],0); -ELEMENTS[55685] = Fluid3D([2245,2414,2469,2665],0); -ELEMENTS[55686] = Fluid3D([5844,6190,6523,5981],0); -ELEMENTS[55687] = Fluid3D([8386,8477,8653,7558],0); -ELEMENTS[55688] = Fluid3D([11996,12950,12652,12273],0); -ELEMENTS[55689] = Fluid3D([2788,2719,2590,2447],0); -ELEMENTS[55690] = Fluid3D([2788,2719,2447,2561],0); -ELEMENTS[55691] = Fluid3D([6457,5685,5909,5688],0); -ELEMENTS[55692] = Fluid3D([12016,12102,12057,11447],0); -ELEMENTS[55693] = Fluid3D([12016,12102,11447,11423],0); -ELEMENTS[55694] = Fluid3D([12016,12102,11423,11474],0); -ELEMENTS[55695] = Fluid3D([17998,18145,18186,17923],0); -ELEMENTS[55696] = Fluid3D([17998,18145,17923,17864],0); -ELEMENTS[55697] = Fluid3D([17998,18145,17864,18095],0); -ELEMENTS[55698] = Fluid3D([10698,11042,11445,11028],0); -ELEMENTS[55699] = Fluid3D([13441,12696,12162,12276],0); -ELEMENTS[55700] = Fluid3D([12696,12162,12276,11392],0); -ELEMENTS[55701] = Fluid3D([8144,8726,8258,8390],0); -ELEMENTS[55702] = Fluid3D([8689,7658,8404,8492],0); -ELEMENTS[55703] = Fluid3D([18480,18474,18599,18567],0); -ELEMENTS[55704] = Fluid3D([11829,12248,11824,10812],0); -ELEMENTS[55705] = Fluid3D([3438,3788,3779,3863],0); -ELEMENTS[55706] = Fluid3D([5280,5720,5255,5890],0); -ELEMENTS[55707] = Fluid3D([5280,5720,5890,6069],0); -ELEMENTS[55708] = Fluid3D([5720,5255,5890,6165],0); -ELEMENTS[55709] = Fluid3D([5890,5720,6165,6518],0); -ELEMENTS[55710] = Fluid3D([5890,5720,6518,6069],0); -ELEMENTS[55711] = Fluid3D([9699,8694,9321,9095],0); -ELEMENTS[55712] = Fluid3D([15433,15863,15118,15328],0); -ELEMENTS[55713] = Fluid3D([7804,7969,7036,7252],0); -ELEMENTS[55714] = Fluid3D([16128,15859,16478,16329],0); -ELEMENTS[55715] = Fluid3D([17613,17768,17692,17456],0); -ELEMENTS[55716] = Fluid3D([17768,17692,17456,17873],0); -ELEMENTS[55717] = Fluid3D([17456,17768,17873,17415],0); -ELEMENTS[55718] = Fluid3D([12241,12700,12945,12146],0); -ELEMENTS[55719] = Fluid3D([10345,9503,10515,9485],0); -ELEMENTS[55720] = Fluid3D([10345,9503,9485,9648],0); -ELEMENTS[55721] = Fluid3D([16185,16389,16426,16372],0); -ELEMENTS[55722] = Fluid3D([10900,10856,11206,11522],0); -ELEMENTS[55723] = Fluid3D([10022,9255,10185,10503],0); -ELEMENTS[55724] = Fluid3D([10022,9255,10503,9567],0); -ELEMENTS[55725] = Fluid3D([13386,13567,13831,14317],0); -ELEMENTS[55726] = Fluid3D([6098,6861,6332,7193],0); -ELEMENTS[55727] = Fluid3D([6726,7478,6555,7114],0); -ELEMENTS[55728] = Fluid3D([6555,6726,7114,6229],0); -ELEMENTS[55729] = Fluid3D([7114,6555,6229,7231],0); -ELEMENTS[55730] = Fluid3D([7478,6555,7114,7050],0); -ELEMENTS[55731] = Fluid3D([7478,6555,7050,6965],0); -ELEMENTS[55732] = Fluid3D([6555,7050,6965,6091],0); -ELEMENTS[55733] = Fluid3D([6555,7114,7050,7231],0); -ELEMENTS[55734] = Fluid3D([7050,6555,7231,6061],0); -ELEMENTS[55735] = Fluid3D([10062,9270,9656,9025],0); -ELEMENTS[55736] = Fluid3D([15350,14848,14535,14821],0); -ELEMENTS[55737] = Fluid3D([16365,16560,16385,15840],0); -ELEMENTS[55738] = Fluid3D([16385,16365,15840,15944],0); -ELEMENTS[55739] = Fluid3D([13611,14439,13445,13740],0); -ELEMENTS[55740] = Fluid3D([13445,13611,13740,13175],0); -ELEMENTS[55741] = Fluid3D([13611,13740,13175,14181],0); -ELEMENTS[55742] = Fluid3D([13611,14439,13740,14181],0); -ELEMENTS[55743] = Fluid3D([8794,8994,9440,8622],0); -ELEMENTS[55744] = Fluid3D([11066,10983,11390,12093],0); -ELEMENTS[55745] = Fluid3D([5926,6225,5756,5360],0); -ELEMENTS[55746] = Fluid3D([3460,3154,3527,3193],0); -ELEMENTS[55747] = Fluid3D([3154,3527,3193,3040],0); -ELEMENTS[55748] = Fluid3D([3469,3200,3182,3797],0); -ELEMENTS[55749] = Fluid3D([17748,17876,17832,18003],0); -ELEMENTS[55750] = Fluid3D([17748,17876,18003,18097],0); -ELEMENTS[55751] = Fluid3D([17876,17832,18003,18232],0); -ELEMENTS[55752] = Fluid3D([17876,18003,18097,18232],0); -ELEMENTS[55753] = Fluid3D([1693,1698,1610,1759],0); -ELEMENTS[55754] = Fluid3D([6955,6796,6300,6966],0); -ELEMENTS[55755] = Fluid3D([6300,6955,6966,6144],0); -ELEMENTS[55756] = Fluid3D([6300,6955,6144,6126],0); -ELEMENTS[55757] = Fluid3D([6144,6300,6126,5811],0); -ELEMENTS[55758] = Fluid3D([6144,6300,5811,6075],0); -ELEMENTS[55759] = Fluid3D([6144,6300,6075,6966],0); -ELEMENTS[55760] = Fluid3D([18217,18367,18198,18356],0); -ELEMENTS[55761] = Fluid3D([18367,18198,18356,18476],0); -ELEMENTS[55762] = Fluid3D([2970,2745,2849,3127],0); -ELEMENTS[55763] = Fluid3D([17939,18087,17832,17740],0); -ELEMENTS[55764] = Fluid3D([10577,9949,9486,9002],0); -ELEMENTS[55765] = Fluid3D([18398,18404,18222,18494],0); -ELEMENTS[55766] = Fluid3D([2047,2199,2018,2147],0); -ELEMENTS[55767] = Fluid3D([2047,2199,2147,2301],0); -ELEMENTS[55768] = Fluid3D([2199,2018,2147,2381],0); -ELEMENTS[55769] = Fluid3D([2147,2199,2381,2301],0); -ELEMENTS[55770] = Fluid3D([2491,2695,2322,2565],0); -ELEMENTS[55771] = Fluid3D([2491,2695,2565,2761],0); -ELEMENTS[55772] = Fluid3D([2695,2565,2761,2851],0); -ELEMENTS[55773] = Fluid3D([2491,2695,2761,2813],0); -ELEMENTS[55774] = Fluid3D([2491,2695,2813,2819],0); -ELEMENTS[55775] = Fluid3D([2695,2813,2819,3038],0); -ELEMENTS[55776] = Fluid3D([2695,2322,2565,2683],0); -ELEMENTS[55777] = Fluid3D([2565,2695,2683,2851],0); -ELEMENTS[55778] = Fluid3D([2673,2827,2744,3081],0); -ELEMENTS[55779] = Fluid3D([2827,2744,3081,2872],0); -ELEMENTS[55780] = Fluid3D([14624,14962,14049,14798],0); -ELEMENTS[55781] = Fluid3D([14049,14624,14798,14263],0); -ELEMENTS[55782] = Fluid3D([3025,2987,3032,3410],0); -ELEMENTS[55783] = Fluid3D([11363,11332,10516,11514],0); -ELEMENTS[55784] = Fluid3D([4809,4715,4390,4229],0); -ELEMENTS[55785] = Fluid3D([15530,15841,15135,14811],0); -ELEMENTS[55786] = Fluid3D([14770,14801,14985,15611],0); -ELEMENTS[55787] = Fluid3D([12187,10978,11117,12080],0); -ELEMENTS[55788] = Fluid3D([13603,13621,13361,14254],0); -ELEMENTS[55789] = Fluid3D([13179,13855,13521,12763],0); -ELEMENTS[55790] = Fluid3D([13521,13179,12763,13205],0); -ELEMENTS[55791] = Fluid3D([13179,13855,12763,13433],0); -ELEMENTS[55792] = Fluid3D([13320,13863,13123,12785],0); -ELEMENTS[55793] = Fluid3D([11411,11692,12358,12619],0); -ELEMENTS[55794] = Fluid3D([4655,4251,4055,4128],0); -ELEMENTS[55795] = Fluid3D([11614,12301,12448,12372],0); -ELEMENTS[55796] = Fluid3D([8180,8865,8875,9106],0); -ELEMENTS[55797] = Fluid3D([8180,8865,9106,9446],0); -ELEMENTS[55798] = Fluid3D([8865,9106,9446,9824],0); -ELEMENTS[55799] = Fluid3D([9106,9446,9824,9209],0); -ELEMENTS[55800] = Fluid3D([9824,9106,9209,9931],0); -ELEMENTS[55801] = Fluid3D([9209,9824,9931,9734],0); -ELEMENTS[55802] = Fluid3D([9824,9106,9931,9628],0); -ELEMENTS[55803] = Fluid3D([9106,9209,9931,9628],0); -ELEMENTS[55804] = Fluid3D([9931,9824,9628,10414],0); -ELEMENTS[55805] = Fluid3D([9209,9931,9628,9017],0); -ELEMENTS[55806] = Fluid3D([9209,9931,9017,10182],0); -ELEMENTS[55807] = Fluid3D([9209,9931,10182,9734],0); -ELEMENTS[55808] = Fluid3D([8865,8875,9106,9824],0); -ELEMENTS[55809] = Fluid3D([8875,9106,9824,9628],0); -ELEMENTS[55810] = Fluid3D([8875,8180,9106,8570],0); -ELEMENTS[55811] = Fluid3D([10810,11056,11928,12000],0); -ELEMENTS[55812] = Fluid3D([6046,5802,5891,5430],0); -ELEMENTS[55813] = Fluid3D([5802,5891,5430,5294],0); -ELEMENTS[55814] = Fluid3D([5802,5891,5294,5975],0); -ELEMENTS[55815] = Fluid3D([5430,5802,5294,4891],0); -ELEMENTS[55816] = Fluid3D([2502,2367,2602,2257],0); -ELEMENTS[55817] = Fluid3D([8009,8531,8540,9504],0); -ELEMENTS[55818] = Fluid3D([11765,11946,12076,12707],0); -ELEMENTS[55819] = Fluid3D([4331,3897,3832,4272],0); -ELEMENTS[55820] = Fluid3D([5888,5261,5684,5626],0); -ELEMENTS[55821] = Fluid3D([4360,3916,4466,4269],0); -ELEMENTS[55822] = Fluid3D([8465,9063,9348,7934],0); -ELEMENTS[55823] = Fluid3D([5035,4769,4893,5564],0); -ELEMENTS[55824] = Fluid3D([10257,10556,10449,11059],0); -ELEMENTS[55825] = Fluid3D([10449,10257,11059,9914],0); -ELEMENTS[55826] = Fluid3D([10556,10449,11059,10752],0); -ELEMENTS[55827] = Fluid3D([14530,14972,15374,14495],0); -ELEMENTS[55828] = Fluid3D([9149,8310,8271,9043],0); -ELEMENTS[55829] = Fluid3D([9149,8310,9043,8044],0); -ELEMENTS[55830] = Fluid3D([8310,8271,9043,8044],0); -ELEMENTS[55831] = Fluid3D([14713,14004,14701,14397],0); -ELEMENTS[55832] = Fluid3D([17858,18171,18051,18110],0); -ELEMENTS[55833] = Fluid3D([15412,15846,15845,16042],0); -ELEMENTS[55834] = Fluid3D([2364,2170,2240,2282],0); -ELEMENTS[55835] = Fluid3D([2240,2364,2282,2512],0); -ELEMENTS[55836] = Fluid3D([2240,2364,2512,2677],0); -ELEMENTS[55837] = Fluid3D([12668,12374,13254,13114],0); -ELEMENTS[55838] = Fluid3D([6144,5607,5444,5811],0); -ELEMENTS[55839] = Fluid3D([2729,2890,2981,2988],0); -ELEMENTS[55840] = Fluid3D([2729,2890,2988,2649],0); -ELEMENTS[55841] = Fluid3D([15115,15686,15141,14987],0); -ELEMENTS[55842] = Fluid3D([3424,3125,3573,3415],0); -ELEMENTS[55843] = Fluid3D([4801,4508,4668,4463],0); -ELEMENTS[55844] = Fluid3D([10321,10352,10135,9722],0); -ELEMENTS[55845] = Fluid3D([10135,10321,9722,11091],0); -ELEMENTS[55846] = Fluid3D([10321,9722,11091,9882],0); -ELEMENTS[55847] = Fluid3D([10321,9722,9882,9816],0); -ELEMENTS[55848] = Fluid3D([9882,10321,9816,10467],0); -ELEMENTS[55849] = Fluid3D([10321,9816,10467,11230],0); -ELEMENTS[55850] = Fluid3D([10321,9722,9816,9465],0); -ELEMENTS[55851] = Fluid3D([10321,9722,9465,10352],0); -ELEMENTS[55852] = Fluid3D([9465,10321,10352,9908],0); -ELEMENTS[55853] = Fluid3D([17239,17101,16839,16924],0); -ELEMENTS[55854] = Fluid3D([14264,14410,13334,13925],0); -ELEMENTS[55855] = Fluid3D([14997,14851,15596,15126],0); -ELEMENTS[55856] = Fluid3D([16671,16335,16396,16407],0); -ELEMENTS[55857] = Fluid3D([9237,9275,8630,8403],0); -ELEMENTS[55858] = Fluid3D([9187,9398,9636,10829],0); -ELEMENTS[55859] = Fluid3D([6652,5784,5935,6492],0); -ELEMENTS[55860] = Fluid3D([8665,8808,8389,9351],0); -ELEMENTS[55861] = Fluid3D([8665,8808,9351,9860],0); -ELEMENTS[55862] = Fluid3D([15911,15907,15514,16018],0); -ELEMENTS[55863] = Fluid3D([16673,16199,16563,16872],0); -ELEMENTS[55864] = Fluid3D([6405,5809,5637,6583],0); -ELEMENTS[55865] = Fluid3D([6217,6890,6402,6459],0); -ELEMENTS[55866] = Fluid3D([8756,8965,8483,9223],0); -ELEMENTS[55867] = Fluid3D([6534,6347,6765,7333],0); -ELEMENTS[55868] = Fluid3D([14220,14737,14187,13707],0); -ELEMENTS[55869] = Fluid3D([11121,12325,12261,11429],0); -ELEMENTS[55870] = Fluid3D([7804,7277,6767,7036],0); -ELEMENTS[55871] = Fluid3D([3893,3668,3642,4288],0); -ELEMENTS[55872] = Fluid3D([13415,13302,14033,13596],0); -ELEMENTS[55873] = Fluid3D([2079,2006,1941,1821],0); -ELEMENTS[55874] = Fluid3D([15773,15365,16165,15967],0); -ELEMENTS[55875] = Fluid3D([12260,12555,12468,13575],0); -ELEMENTS[55876] = Fluid3D([17613,17843,17692,17952],0); -ELEMENTS[55877] = Fluid3D([11004,10772,11029,11718],0); -ELEMENTS[55878] = Fluid3D([16230,15874,15902,15879],0); -ELEMENTS[55879] = Fluid3D([6365,7091,7242,6897],0); -ELEMENTS[55880] = Fluid3D([8819,9809,9623,9850],0); -ELEMENTS[55881] = Fluid3D([9623,8819,9850,9319],0); -ELEMENTS[55882] = Fluid3D([17814,17761,17449,17412],0); -ELEMENTS[55883] = Fluid3D([17761,17449,17412,17502],0); -ELEMENTS[55884] = Fluid3D([17412,17761,17502,17577],0); -ELEMENTS[55885] = Fluid3D([17412,17761,17577,17837],0); -ELEMENTS[55886] = Fluid3D([15399,15039,15364,14625],0); -ELEMENTS[55887] = Fluid3D([15399,15039,14625,14604],0); -ELEMENTS[55888] = Fluid3D([15364,15399,14625,15385],0); -ELEMENTS[55889] = Fluid3D([15600,15455,15339,16030],0); -ELEMENTS[55890] = Fluid3D([12676,11864,12345,12759],0); -ELEMENTS[55891] = Fluid3D([11743,12095,11961,12431],0); -ELEMENTS[55892] = Fluid3D([2338,2270,2486,2341],0); -ELEMENTS[55893] = Fluid3D([2270,2486,2341,2421],0); -ELEMENTS[55894] = Fluid3D([2270,2486,2421,2544],0); -ELEMENTS[55895] = Fluid3D([2486,2421,2544,2709],0); -ELEMENTS[55896] = Fluid3D([2338,2270,2341,2074],0); -ELEMENTS[55897] = Fluid3D([2270,2341,2074,2228],0); -ELEMENTS[55898] = Fluid3D([2270,2341,2228,2421],0); -ELEMENTS[55899] = Fluid3D([2341,2074,2228,2252],0); -ELEMENTS[55900] = Fluid3D([2228,2341,2252,2454],0); -ELEMENTS[55901] = Fluid3D([2228,2341,2454,2439],0); -ELEMENTS[55902] = Fluid3D([2228,2341,2439,2421],0); -ELEMENTS[55903] = Fluid3D([2228,2270,2421,2173],0); -ELEMENTS[55904] = Fluid3D([2439,2228,2421,2173],0); -ELEMENTS[55905] = Fluid3D([2341,2252,2454,2354],0); -ELEMENTS[55906] = Fluid3D([2341,2252,2354,2074],0); -ELEMENTS[55907] = Fluid3D([2252,2454,2354,2476],0); -ELEMENTS[55908] = Fluid3D([2354,2252,2476,2280],0); -ELEMENTS[55909] = Fluid3D([2354,2252,2280,2099],0); -ELEMENTS[55910] = Fluid3D([2354,2252,2099,2074],0); -ELEMENTS[55911] = Fluid3D([2074,2270,2228,2065],0); -ELEMENTS[55912] = Fluid3D([2270,2228,2065,2173],0); -ELEMENTS[55913] = Fluid3D([2486,2341,2421,2439],0); -ELEMENTS[55914] = Fluid3D([2421,2486,2439,2734],0); -ELEMENTS[55915] = Fluid3D([2421,2486,2734,2709],0); -ELEMENTS[55916] = Fluid3D([2270,2486,2544,2287],0); -ELEMENTS[55917] = Fluid3D([14422,15046,14014,14445],0); -ELEMENTS[55918] = Fluid3D([14099,14303,14054,13438],0); -ELEMENTS[55919] = Fluid3D([14099,14303,13438,14056],0); -ELEMENTS[55920] = Fluid3D([14303,13438,14056,13802],0); -ELEMENTS[55921] = Fluid3D([9029,8220,8163,8540],0); -ELEMENTS[55922] = Fluid3D([9029,8220,8540,9476],0); -ELEMENTS[55923] = Fluid3D([8220,8540,9476,8162],0); -ELEMENTS[55924] = Fluid3D([8220,8540,8162,7898],0); -ELEMENTS[55925] = Fluid3D([8540,9476,8162,8685],0); -ELEMENTS[55926] = Fluid3D([8540,9476,8685,7982],0); -ELEMENTS[55927] = Fluid3D([8202,9151,8496,9109],0); -ELEMENTS[55928] = Fluid3D([8202,9151,9109,8819],0); -ELEMENTS[55929] = Fluid3D([16068,16167,15550,16194],0); -ELEMENTS[55930] = Fluid3D([9833,9395,10618,10031],0); -ELEMENTS[55931] = Fluid3D([2241,2327,2137,2052],0); -ELEMENTS[55932] = Fluid3D([2241,2327,2052,2154],0); -ELEMENTS[55933] = Fluid3D([2241,2327,2154,2374],0); -ELEMENTS[55934] = Fluid3D([2241,2327,2374,2615],0); -ELEMENTS[55935] = Fluid3D([8545,9114,9135,8509],0); -ELEMENTS[55936] = Fluid3D([6278,7081,6299,6008],0); -ELEMENTS[55937] = Fluid3D([16551,16576,16972,16683],0); -ELEMENTS[55938] = Fluid3D([13241,13162,12590,12243],0); -ELEMENTS[55939] = Fluid3D([13241,13162,12243,12838],0); -ELEMENTS[55940] = Fluid3D([14425,15130,15002,15018],0); -ELEMENTS[55941] = Fluid3D([8618,8881,7899,8405],0); -ELEMENTS[55942] = Fluid3D([5197,5165,4624,4958],0); -ELEMENTS[55943] = Fluid3D([9461,10357,10635,9828],0); -ELEMENTS[55944] = Fluid3D([14010,13252,13762,13687],0); -ELEMENTS[55945] = Fluid3D([12940,13427,12849,14049],0); -ELEMENTS[55946] = Fluid3D([6299,6066,6263,6957],0); -ELEMENTS[55947] = Fluid3D([17155,17031,17163,17431],0); -ELEMENTS[55948] = Fluid3D([18199,18134,18291,18106],0); -ELEMENTS[55949] = Fluid3D([4137,3730,3797,3890],0); -ELEMENTS[55950] = Fluid3D([12746,13137,13316,13826],0); -ELEMENTS[55951] = Fluid3D([1967,1960,1942,1832],0); -ELEMENTS[55952] = Fluid3D([1967,1960,1832,1848],0); -ELEMENTS[55953] = Fluid3D([1960,1942,1832,1816],0); -ELEMENTS[55954] = Fluid3D([1960,1832,1848,1831],0); -ELEMENTS[55955] = Fluid3D([1960,1832,1831,1861],0); -ELEMENTS[55956] = Fluid3D([11084,10262,11374,11575],0); -ELEMENTS[55957] = Fluid3D([2805,2775,2639,2996],0); -ELEMENTS[55958] = Fluid3D([2639,2805,2996,3112],0); -ELEMENTS[55959] = Fluid3D([2996,2639,3112,3053],0); -ELEMENTS[55960] = Fluid3D([3112,2996,3053,3124],0); -ELEMENTS[55961] = Fluid3D([3112,2996,3124,2805],0); -ELEMENTS[55962] = Fluid3D([2996,3053,3124,2775],0); -ELEMENTS[55963] = Fluid3D([2996,3124,2805,2775],0); -ELEMENTS[55964] = Fluid3D([16342,16698,16088,16581],0); -ELEMENTS[55965] = Fluid3D([16342,16698,16581,16915],0); -ELEMENTS[55966] = Fluid3D([16088,16342,16581,16449],0); -ELEMENTS[55967] = Fluid3D([16698,16088,16581,16558],0); -ELEMENTS[55968] = Fluid3D([12066,11118,11823,12227],0); -ELEMENTS[55969] = Fluid3D([4066,4074,4609,4330],0); -ELEMENTS[55970] = Fluid3D([16324,16554,16116,16773],0); -ELEMENTS[55971] = Fluid3D([12052,12081,11624,11222],0); -ELEMENTS[55972] = Fluid3D([12081,11624,11222,11667],0); -ELEMENTS[55973] = Fluid3D([11624,11222,11667,11194],0); -ELEMENTS[55974] = Fluid3D([11624,11222,11194,11156],0); -ELEMENTS[55975] = Fluid3D([11222,11667,11194,10225],0); -ELEMENTS[55976] = Fluid3D([11222,12081,11667,10925],0); -ELEMENTS[55977] = Fluid3D([11667,11222,10925,10225],0); -ELEMENTS[55978] = Fluid3D([11194,11222,10225,11156],0); -ELEMENTS[55979] = Fluid3D([11624,11222,11156,10922],0); -ELEMENTS[55980] = Fluid3D([11624,11222,10922,12052],0); -ELEMENTS[55981] = Fluid3D([10181,9444,10288,9936],0); -ELEMENTS[55982] = Fluid3D([17229,17214,17628,17376],0); -ELEMENTS[55983] = Fluid3D([17628,17229,17376,17621],0); -ELEMENTS[55984] = Fluid3D([9156,9838,10103,9083],0); -ELEMENTS[55985] = Fluid3D([13722,13407,13147,14020],0); -ELEMENTS[55986] = Fluid3D([13722,13407,14020,14660],0); -ELEMENTS[55987] = Fluid3D([13407,13147,14020,13564],0); -ELEMENTS[55988] = Fluid3D([14723,14598,14116,14893],0); -ELEMENTS[55989] = Fluid3D([14723,14598,14893,15414],0); -ELEMENTS[55990] = Fluid3D([14723,14598,15414,14774],0); -ELEMENTS[55991] = Fluid3D([14598,14893,15414,15535],0); -ELEMENTS[55992] = Fluid3D([3882,4055,3748,4080],0); -ELEMENTS[55993] = Fluid3D([4055,3748,4080,4166],0); -ELEMENTS[55994] = Fluid3D([18127,18345,18428,18382],0); -ELEMENTS[55995] = Fluid3D([18345,18428,18382,18505],0); -ELEMENTS[55996] = Fluid3D([18345,18428,18505,18536],0); -ELEMENTS[55997] = Fluid3D([18345,18428,18536,18442],0); -ELEMENTS[55998] = Fluid3D([3914,3787,4302,4047],0); -ELEMENTS[55999] = Fluid3D([14638,14781,15025,14545],0); -ELEMENTS[56000] = Fluid3D([2582,2740,3057,2705],0); -ELEMENTS[56001] = Fluid3D([7129,7242,8140,7763],0); -ELEMENTS[56002] = Fluid3D([4738,4219,4389,4091],0); -ELEMENTS[56003] = Fluid3D([3419,3687,3794,3333],0); -ELEMENTS[56004] = Fluid3D([12055,11183,11918,11230],0); -ELEMENTS[56005] = Fluid3D([4834,4798,4272,4793],0); -ELEMENTS[56006] = Fluid3D([8144,7679,8285,8390],0); -ELEMENTS[56007] = Fluid3D([12491,11972,12079,11807],0); -ELEMENTS[56008] = Fluid3D([16071,15830,15987,16455],0); -ELEMENTS[56009] = Fluid3D([18388,18407,18387,18172],0); -ELEMENTS[56010] = Fluid3D([14369,14304,15078,14367],0); -ELEMENTS[56011] = Fluid3D([11725,12123,10865,12218],0); -ELEMENTS[56012] = Fluid3D([11725,12123,12218,12517],0); -ELEMENTS[56013] = Fluid3D([3198,2851,2969,2664],0); -ELEMENTS[56014] = Fluid3D([15462,15484,15120,14752],0); -ELEMENTS[56015] = Fluid3D([15407,15459,15847,15473],0); -ELEMENTS[56016] = Fluid3D([15576,15865,15267,14974],0); -ELEMENTS[56017] = Fluid3D([6964,6317,6532,7079],0); -ELEMENTS[56018] = Fluid3D([9145,9971,9378,9847],0); -ELEMENTS[56019] = Fluid3D([9378,9145,9847,8871],0); -ELEMENTS[56020] = Fluid3D([9145,9971,9847,9514],0); -ELEMENTS[56021] = Fluid3D([14477,14959,13953,14468],0); -ELEMENTS[56022] = Fluid3D([3229,3184,3191,3640],0); -ELEMENTS[56023] = Fluid3D([9470,9295,9812,10390],0); -ELEMENTS[56024] = Fluid3D([15716,15609,16137,16269],0); -ELEMENTS[56025] = Fluid3D([12129,11433,11397,12531],0); -ELEMENTS[56026] = Fluid3D([13232,13193,12373,12351],0); -ELEMENTS[56027] = Fluid3D([7216,8103,7312,7223],0); -ELEMENTS[56028] = Fluid3D([7312,7216,7223,6679],0); -ELEMENTS[56029] = Fluid3D([11211,11810,11256,10403],0); -ELEMENTS[56030] = Fluid3D([10178,10599,9474,9410],0); -ELEMENTS[56031] = Fluid3D([6995,7218,7609,7996],0); -ELEMENTS[56032] = Fluid3D([1746,1931,1801,1878],0); -ELEMENTS[56033] = Fluid3D([1931,1801,1878,1938],0); -ELEMENTS[56034] = Fluid3D([3398,3036,3200,3248],0); -ELEMENTS[56035] = Fluid3D([3200,3398,3248,3797],0); -ELEMENTS[56036] = Fluid3D([14617,15338,15175,14798],0); -ELEMENTS[56037] = Fluid3D([12214,12181,12921,13097],0); -ELEMENTS[56038] = Fluid3D([11840,11238,11009,11917],0); -ELEMENTS[56039] = Fluid3D([11009,11840,11917,11760],0); -ELEMENTS[56040] = Fluid3D([11917,11009,11760,11204],0); -ELEMENTS[56041] = Fluid3D([3860,4014,3629,3596],0); -ELEMENTS[56042] = Fluid3D([16441,16372,16806,16354],0); -ELEMENTS[56043] = Fluid3D([16441,16372,16354,15971],0); -ELEMENTS[56044] = Fluid3D([16354,16441,15971,16379],0); -ELEMENTS[56045] = Fluid3D([15971,16354,16379,15991],0); -ELEMENTS[56046] = Fluid3D([15971,16354,15991,16372],0); -ELEMENTS[56047] = Fluid3D([16354,15991,16372,16598],0); -ELEMENTS[56048] = Fluid3D([16354,15991,16598,16481],0); -ELEMENTS[56049] = Fluid3D([16354,15991,16481,16379],0); -ELEMENTS[56050] = Fluid3D([16372,16354,16598,16806],0); -ELEMENTS[56051] = Fluid3D([16354,16598,16806,16481],0); -ELEMENTS[56052] = Fluid3D([16598,16372,16806,16948],0); -ELEMENTS[56053] = Fluid3D([16481,16354,16379,16806],0); -ELEMENTS[56054] = Fluid3D([16806,16598,16948,16819],0); -ELEMENTS[56055] = Fluid3D([16806,16598,16819,16481],0); -ELEMENTS[56056] = Fluid3D([16598,16819,16481,16057],0); -ELEMENTS[56057] = Fluid3D([16806,16441,16354,16379],0); -ELEMENTS[56058] = Fluid3D([15991,16372,16598,16303],0); -ELEMENTS[56059] = Fluid3D([16598,15991,16303,16057],0); -ELEMENTS[56060] = Fluid3D([4845,4399,4472,4657],0); -ELEMENTS[56061] = Fluid3D([2166,2118,1987,1922],0); -ELEMENTS[56062] = Fluid3D([17658,17385,17378,17511],0); -ELEMENTS[56063] = Fluid3D([17658,17385,17511,17277],0); -ELEMENTS[56064] = Fluid3D([17511,17658,17277,17698],0); -ELEMENTS[56065] = Fluid3D([17378,17658,17511,17595],0); -ELEMENTS[56066] = Fluid3D([17511,17658,17698,17937],0); -ELEMENTS[56067] = Fluid3D([17511,17658,17937,17595],0); -ELEMENTS[56068] = Fluid3D([6371,6222,5609,5818],0); -ELEMENTS[56069] = Fluid3D([11501,12018,11666,11954],0); -ELEMENTS[56070] = Fluid3D([15950,15927,16500,16294],0); -ELEMENTS[56071] = Fluid3D([15950,15927,16294,15877],0); -ELEMENTS[56072] = Fluid3D([15652,16077,15247,15217],0); -ELEMENTS[56073] = Fluid3D([9608,10158,9363,9585],0); -ELEMENTS[56074] = Fluid3D([5183,5242,5658,5113],0); -ELEMENTS[56075] = Fluid3D([11982,12622,12116,11551],0); -ELEMENTS[56076] = Fluid3D([5470,5590,6091,6090],0); -ELEMENTS[56077] = Fluid3D([6091,5470,6090,5848],0); -ELEMENTS[56078] = Fluid3D([10080,10704,11004,10815],0); -ELEMENTS[56079] = Fluid3D([8485,8030,7909,7595],0); -ELEMENTS[56080] = Fluid3D([16155,16306,16551,16213],0); -ELEMENTS[56081] = Fluid3D([5448,6014,5601,5477],0); -ELEMENTS[56082] = Fluid3D([9411,10486,9981,10721],0); -ELEMENTS[56083] = Fluid3D([11087,11261,10949,12120],0); -ELEMENTS[56084] = Fluid3D([2539,2799,2503,2431],0); -ELEMENTS[56085] = Fluid3D([12057,12720,13225,12533],0); -ELEMENTS[56086] = Fluid3D([12057,12720,12533,11423],0); -ELEMENTS[56087] = Fluid3D([6208,5941,5824,5461],0); -ELEMENTS[56088] = Fluid3D([5369,5251,4880,5822],0); -ELEMENTS[56089] = Fluid3D([8333,7333,7569,7285],0); -ELEMENTS[56090] = Fluid3D([9001,8314,8822,7866],0); -ELEMENTS[56091] = Fluid3D([14858,14351,14808,14460],0); -ELEMENTS[56092] = Fluid3D([6028,5432,6228,5656],0); -ELEMENTS[56093] = Fluid3D([6355,5910,6458,5855],0); -ELEMENTS[56094] = Fluid3D([3459,3630,3795,3877],0); -ELEMENTS[56095] = Fluid3D([3795,3459,3877,3780],0); -ELEMENTS[56096] = Fluid3D([4838,4662,4721,5202],0); -ELEMENTS[56097] = Fluid3D([6938,7142,7760,7582],0); -ELEMENTS[56098] = Fluid3D([7760,6938,7582,7730],0); -ELEMENTS[56099] = Fluid3D([7142,7760,7582,7599],0); -ELEMENTS[56100] = Fluid3D([6938,7142,7582,6413],0); -ELEMENTS[56101] = Fluid3D([7402,6628,7024,7407],0); -ELEMENTS[56102] = Fluid3D([5224,5776,4991,5116],0); -ELEMENTS[56103] = Fluid3D([4991,5224,5116,4640],0); -ELEMENTS[56104] = Fluid3D([5224,5776,5116,5365],0); -ELEMENTS[56105] = Fluid3D([5116,5224,5365,5072],0); -ELEMENTS[56106] = Fluid3D([5224,5776,5365,5729],0); -ELEMENTS[56107] = Fluid3D([5776,5365,5729,5162],0); -ELEMENTS[56108] = Fluid3D([5365,5729,5162,5072],0); -ELEMENTS[56109] = Fluid3D([5365,5729,5072,5125],0); -ELEMENTS[56110] = Fluid3D([5072,5365,5125,5224],0); -ELEMENTS[56111] = Fluid3D([5162,5365,5072,5116],0); -ELEMENTS[56112] = Fluid3D([5162,5365,5116,5776],0); -ELEMENTS[56113] = Fluid3D([5365,5125,5224,5729],0); -ELEMENTS[56114] = Fluid3D([5224,5116,4640,5072],0); -ELEMENTS[56115] = Fluid3D([9416,9458,10265,10455],0); -ELEMENTS[56116] = Fluid3D([9458,10265,10455,10354],0); -ELEMENTS[56117] = Fluid3D([3843,3611,4029,4127],0); -ELEMENTS[56118] = Fluid3D([3843,3611,4127,3851],0); -ELEMENTS[56119] = Fluid3D([10117,9417,10407,10109],0); -ELEMENTS[56120] = Fluid3D([8763,8158,7659,8276],0); -ELEMENTS[56121] = Fluid3D([8763,8158,8276,9054],0); -ELEMENTS[56122] = Fluid3D([8158,7659,8276,7309],0); -ELEMENTS[56123] = Fluid3D([8276,8763,9054,9428],0); -ELEMENTS[56124] = Fluid3D([8276,8158,7309,7811],0); -ELEMENTS[56125] = Fluid3D([8276,8763,9428,8375],0); -ELEMENTS[56126] = Fluid3D([8276,8763,8375,8033],0); -ELEMENTS[56127] = Fluid3D([7659,8763,8276,8033],0); -ELEMENTS[56128] = Fluid3D([8158,8276,9054,7811],0); -ELEMENTS[56129] = Fluid3D([18165,18020,18048,18215],0); -ELEMENTS[56130] = Fluid3D([9892,10561,9851,10779],0); -ELEMENTS[56131] = Fluid3D([14162,13925,13807,14644],0); -ELEMENTS[56132] = Fluid3D([1802,1919,2019,1836],0); -ELEMENTS[56133] = Fluid3D([18329,18297,18470,18347],0); -ELEMENTS[56134] = Fluid3D([14883,14395,14039,14946],0); -ELEMENTS[56135] = Fluid3D([5956,6616,6109,6281],0); -ELEMENTS[56136] = Fluid3D([7310,6806,7119,8065],0); -ELEMENTS[56137] = Fluid3D([14044,14207,13419,13356],0); -ELEMENTS[56138] = Fluid3D([14207,13419,13356,14135],0); -ELEMENTS[56139] = Fluid3D([3597,3248,3174,3398],0); -ELEMENTS[56140] = Fluid3D([3597,3248,3398,3797],0); -ELEMENTS[56141] = Fluid3D([2926,3126,3339,3308],0); -ELEMENTS[56142] = Fluid3D([4555,4254,4027,4510],0); -ELEMENTS[56143] = Fluid3D([4555,4254,4510,4762],0); -ELEMENTS[56144] = Fluid3D([16508,16899,16577,16628],0); -ELEMENTS[56145] = Fluid3D([16508,16899,16628,16953],0); -ELEMENTS[56146] = Fluid3D([14647,13982,13642,13400],0); -ELEMENTS[56147] = Fluid3D([13982,13642,13400,12815],0); -ELEMENTS[56148] = Fluid3D([12118,11683,12450,11852],0); -ELEMENTS[56149] = Fluid3D([4022,4593,4133,4352],0); -ELEMENTS[56150] = Fluid3D([17794,18081,17752,18097],0); -ELEMENTS[56151] = Fluid3D([11185,10606,11783,11326],0); -ELEMENTS[56152] = Fluid3D([5295,5018,5022,5761],0); -ELEMENTS[56153] = Fluid3D([10961,10833,11924,11520],0); -ELEMENTS[56154] = Fluid3D([8778,8548,8967,9814],0); -ELEMENTS[56155] = Fluid3D([11367,11082,10776,9899],0); -ELEMENTS[56156] = Fluid3D([15613,15417,16239,15920],0); -ELEMENTS[56157] = Fluid3D([17009,16922,16644,17365],0); -ELEMENTS[56158] = Fluid3D([17009,16922,17365,17526],0); -ELEMENTS[56159] = Fluid3D([10722,11726,10742,10099],0); -ELEMENTS[56160] = Fluid3D([10742,10722,10099,10349],0); -ELEMENTS[56161] = Fluid3D([10722,10099,10349,10193],0); -ELEMENTS[56162] = Fluid3D([13091,13813,13922,14197],0); -ELEMENTS[56163] = Fluid3D([13147,12248,12670,13407],0); -ELEMENTS[56164] = Fluid3D([14285,13876,13374,14373],0); -ELEMENTS[56165] = Fluid3D([9969,9925,10009,9108],0); -ELEMENTS[56166] = Fluid3D([4935,4775,4334,4527],0); -ELEMENTS[56167] = Fluid3D([9955,9592,8903,9479],0); -ELEMENTS[56168] = Fluid3D([9592,8903,9479,8603],0); -ELEMENTS[56169] = Fluid3D([8903,9479,8603,9402],0); -ELEMENTS[56170] = Fluid3D([9955,9592,9479,10695],0); -ELEMENTS[56171] = Fluid3D([8903,9955,9479,9402],0); -ELEMENTS[56172] = Fluid3D([9592,8903,8603,8251],0); -ELEMENTS[56173] = Fluid3D([8903,8603,8251,7855],0); -ELEMENTS[56174] = Fluid3D([8903,8603,7855,8297],0); -ELEMENTS[56175] = Fluid3D([16281,15910,16403,15631],0); -ELEMENTS[56176] = Fluid3D([13393,13677,13144,13077],0); -ELEMENTS[56177] = Fluid3D([12490,13049,12976,13279],0); -ELEMENTS[56178] = Fluid3D([5022,5018,5476,5761],0); -ELEMENTS[56179] = Fluid3D([11840,11603,12254,11009],0); -ELEMENTS[56180] = Fluid3D([10674,9636,9398,10829],0); -ELEMENTS[56181] = Fluid3D([7968,7615,8417,8398],0); -ELEMENTS[56182] = Fluid3D([18090,17951,18198,18217],0); -ELEMENTS[56183] = Fluid3D([11440,12482,11908,12421],0); -ELEMENTS[56184] = Fluid3D([14368,14805,15120,14820],0); -ELEMENTS[56185] = Fluid3D([12551,12122,12666,11474],0); -ELEMENTS[56186] = Fluid3D([4415,4483,4203,3874],0); -ELEMENTS[56187] = Fluid3D([9621,9678,8634,8905],0); -ELEMENTS[56188] = Fluid3D([6934,7115,6954,7916],0); -ELEMENTS[56189] = Fluid3D([15298,15074,15050,14538],0); -ELEMENTS[56190] = Fluid3D([15074,15050,14538,14217],0); -ELEMENTS[56191] = Fluid3D([15298,15074,14538,14892],0); -ELEMENTS[56192] = Fluid3D([15050,14538,14217,14457],0); -ELEMENTS[56193] = Fluid3D([14538,14217,14457,13561],0); -ELEMENTS[56194] = Fluid3D([15050,14538,14457,15278],0); -ELEMENTS[56195] = Fluid3D([10049,9165,9819,9038],0); -ELEMENTS[56196] = Fluid3D([9165,9819,9038,9393],0); -ELEMENTS[56197] = Fluid3D([9038,9165,9393,8337],0); -ELEMENTS[56198] = Fluid3D([9819,9038,9393,9230],0); -ELEMENTS[56199] = Fluid3D([17325,17599,17310,17214],0); -ELEMENTS[56200] = Fluid3D([8221,8188,7820,7393],0); -ELEMENTS[56201] = Fluid3D([6768,7030,7076,6097],0); -ELEMENTS[56202] = Fluid3D([10946,10993,10028,10343],0); -ELEMENTS[56203] = Fluid3D([6936,7311,7096,7970],0); -ELEMENTS[56204] = Fluid3D([6936,7311,7970,7520],0); -ELEMENTS[56205] = Fluid3D([17772,17896,17770,18059],0); -ELEMENTS[56206] = Fluid3D([17772,17896,18059,18046],0); -ELEMENTS[56207] = Fluid3D([11124,10672,11230,11433],0); -ELEMENTS[56208] = Fluid3D([11124,10672,11433,11908],0); -ELEMENTS[56209] = Fluid3D([17893,17503,17784,17785],0); -ELEMENTS[56210] = Fluid3D([16113,16334,16688,16006],0); -ELEMENTS[56211] = Fluid3D([17144,16677,16810,16695],0); -ELEMENTS[56212] = Fluid3D([18620,18587,18660,18574],0); -ELEMENTS[56213] = Fluid3D([3554,3940,3661,4295],0); -ELEMENTS[56214] = Fluid3D([18302,18450,18478,18437],0); -ELEMENTS[56215] = Fluid3D([17678,17505,17173,17444],0); -ELEMENTS[56216] = Fluid3D([6137,6221,6822,6004],0); -ELEMENTS[56217] = Fluid3D([6221,6822,6004,5790],0); -ELEMENTS[56218] = Fluid3D([16541,16727,17020,16868],0); -ELEMENTS[56219] = Fluid3D([4879,5251,5022,4740],0); -ELEMENTS[56220] = Fluid3D([16099,16347,15893,16607],0); -ELEMENTS[56221] = Fluid3D([16134,16161,15535,16031],0); -ELEMENTS[56222] = Fluid3D([16134,16161,16031,16569],0); -ELEMENTS[56223] = Fluid3D([16134,16161,16569,16701],0); -ELEMENTS[56224] = Fluid3D([16031,16134,16569,16448],0); -ELEMENTS[56225] = Fluid3D([16569,16134,16701,16690],0); -ELEMENTS[56226] = Fluid3D([16569,16134,16690,16613],0); -ELEMENTS[56227] = Fluid3D([9258,9205,10363,10018],0); -ELEMENTS[56228] = Fluid3D([12495,12788,12191,13400],0); -ELEMENTS[56229] = Fluid3D([3124,3406,3053,3112],0); -ELEMENTS[56230] = Fluid3D([9543,9903,10534,10058],0); -ELEMENTS[56231] = Fluid3D([17784,17893,17785,18118],0); -ELEMENTS[56232] = Fluid3D([17784,17893,18118,17941],0); -ELEMENTS[56233] = Fluid3D([13955,13093,13668,13190],0); -ELEMENTS[56234] = Fluid3D([18345,18374,18347,18536],0); -ELEMENTS[56235] = Fluid3D([8300,7731,8355,8622],0); -ELEMENTS[56236] = Fluid3D([12344,12326,11832,12673],0); -ELEMENTS[56237] = Fluid3D([6906,6443,7253,6406],0); -ELEMENTS[56238] = Fluid3D([10440,10262,11037,11575],0); -ELEMENTS[56239] = Fluid3D([11091,11918,11230,11397],0); -ELEMENTS[56240] = Fluid3D([9479,9592,8603,9252],0); -ELEMENTS[56241] = Fluid3D([8603,9479,9252,9402],0); -ELEMENTS[56242] = Fluid3D([9479,9592,9252,9820],0); -ELEMENTS[56243] = Fluid3D([9252,9479,9820,10134],0); -ELEMENTS[56244] = Fluid3D([9252,9479,10134,9402],0); -ELEMENTS[56245] = Fluid3D([9479,10134,9402,9955],0); -ELEMENTS[56246] = Fluid3D([9479,9592,9820,10409],0); -ELEMENTS[56247] = Fluid3D([9592,9820,10409,10314],0); -ELEMENTS[56248] = Fluid3D([9820,9479,10409,10134],0); -ELEMENTS[56249] = Fluid3D([9820,10409,10314,10875],0); -ELEMENTS[56250] = Fluid3D([9820,10409,10875,10134],0); -ELEMENTS[56251] = Fluid3D([10409,10314,10875,10695],0); -ELEMENTS[56252] = Fluid3D([10875,10409,10695,10134],0); -ELEMENTS[56253] = Fluid3D([10409,10314,10695,9592],0); -ELEMENTS[56254] = Fluid3D([10695,10409,9592,9479],0); -ELEMENTS[56255] = Fluid3D([9479,10409,10134,10695],0); -ELEMENTS[56256] = Fluid3D([9592,9820,10314,9220],0); -ELEMENTS[56257] = Fluid3D([9479,10134,9955,10695],0); -ELEMENTS[56258] = Fluid3D([9592,9252,9820,8515],0); -ELEMENTS[56259] = Fluid3D([2495,2749,2899,2517],0); -ELEMENTS[56260] = Fluid3D([4377,4653,5028,4759],0); -ELEMENTS[56261] = Fluid3D([12432,11448,11982,12041],0); -ELEMENTS[56262] = Fluid3D([14571,15225,14853,15406],0); -ELEMENTS[56263] = Fluid3D([15225,14853,15406,15723],0); -ELEMENTS[56264] = Fluid3D([8344,7501,8296,8350],0); -ELEMENTS[56265] = Fluid3D([8296,8344,8350,9119],0); -ELEMENTS[56266] = Fluid3D([8344,8350,9119,8884],0); -ELEMENTS[56267] = Fluid3D([8350,8296,9119,8816],0); -ELEMENTS[56268] = Fluid3D([9119,8350,8816,8884],0); -ELEMENTS[56269] = Fluid3D([8350,8296,8816,8166],0); -ELEMENTS[56270] = Fluid3D([8947,8475,9601,9120],0); -ELEMENTS[56271] = Fluid3D([3639,3158,3480,3245],0); -ELEMENTS[56272] = Fluid3D([7653,8070,7586,7359],0); -ELEMENTS[56273] = Fluid3D([5475,5205,5466,6111],0); -ELEMENTS[56274] = Fluid3D([7304,8044,7485,7852],0); -ELEMENTS[56275] = Fluid3D([15842,15364,16000,15856],0); -ELEMENTS[56276] = Fluid3D([16836,17168,16898,17136],0); -ELEMENTS[56277] = Fluid3D([14135,13644,14148,12960],0); -ELEMENTS[56278] = Fluid3D([18648,18600,18639,18663],0); -ELEMENTS[56279] = Fluid3D([9908,11016,11124,11230],0); -ELEMENTS[56280] = Fluid3D([7785,7831,7731,6875],0); -ELEMENTS[56281] = Fluid3D([16190,16649,16493,16758],0); -ELEMENTS[56282] = Fluid3D([9687,10180,9146,9284],0); -ELEMENTS[56283] = Fluid3D([12195,12133,11280,11944],0); -ELEMENTS[56284] = Fluid3D([12133,11280,11944,11872],0); -ELEMENTS[56285] = Fluid3D([7408,7767,6813,7869],0); -ELEMENTS[56286] = Fluid3D([17673,17715,17908,17484],0); -ELEMENTS[56287] = Fluid3D([10026,10429,11057,10372],0); -ELEMENTS[56288] = Fluid3D([10429,11057,10372,11800],0); -ELEMENTS[56289] = Fluid3D([12554,13215,12507,12088],0); -ELEMENTS[56290] = Fluid3D([14739,14859,15031,15441],0); -ELEMENTS[56291] = Fluid3D([16865,16438,16729,16623],0); -ELEMENTS[56292] = Fluid3D([16438,16729,16623,16213],0); -ELEMENTS[56293] = Fluid3D([10899,11144,10020,10091],0); -ELEMENTS[56294] = Fluid3D([10020,10899,10091,10398],0); -ELEMENTS[56295] = Fluid3D([11144,10020,10091,10721],0); -ELEMENTS[56296] = Fluid3D([10459,10424,11236,11385],0); -ELEMENTS[56297] = Fluid3D([17294,17699,17485,17415],0); -ELEMENTS[56298] = Fluid3D([5969,6150,6406,5419],0); -ELEMENTS[56299] = Fluid3D([16162,15695,15767,16316],0); -ELEMENTS[56300] = Fluid3D([2156,2226,1992,2025],0); -ELEMENTS[56301] = Fluid3D([2156,2226,2025,2203],0); -ELEMENTS[56302] = Fluid3D([2156,2226,2203,2366],0); -ELEMENTS[56303] = Fluid3D([2226,2025,2203,2170],0); -ELEMENTS[56304] = Fluid3D([2226,2025,2170,2047],0); -ELEMENTS[56305] = Fluid3D([5345,5179,5206,4580],0); -ELEMENTS[56306] = Fluid3D([5240,5079,5686,5957],0); -ELEMENTS[56307] = Fluid3D([9950,9354,9297,8664],0); -ELEMENTS[56308] = Fluid3D([15943,15673,16199,16454],0); -ELEMENTS[56309] = Fluid3D([4176,4139,4067,3731],0); -ELEMENTS[56310] = Fluid3D([4176,4139,3731,3745],0); -ELEMENTS[56311] = Fluid3D([4139,3731,3745,3503],0); -ELEMENTS[56312] = Fluid3D([3731,3745,3503,3604],0); -ELEMENTS[56313] = Fluid3D([3731,3745,3604,4176],0); -ELEMENTS[56314] = Fluid3D([3503,3731,3604,3563],0); -ELEMENTS[56315] = Fluid3D([3503,3731,3563,4067],0); -ELEMENTS[56316] = Fluid3D([3604,3731,4176,3881],0); -ELEMENTS[56317] = Fluid3D([3503,3731,4067,4139],0); -ELEMENTS[56318] = Fluid3D([3604,3731,3881,3563],0); -ELEMENTS[56319] = Fluid3D([3731,4176,3881,4067],0); -ELEMENTS[56320] = Fluid3D([10503,10726,11701,11163],0); -ELEMENTS[56321] = Fluid3D([10503,10726,11163,10185],0); -ELEMENTS[56322] = Fluid3D([10726,11701,11163,11537],0); -ELEMENTS[56323] = Fluid3D([11701,11163,11537,12153],0); -ELEMENTS[56324] = Fluid3D([11163,10726,11537,10185],0); -ELEMENTS[56325] = Fluid3D([11945,12388,12924,11935],0); -ELEMENTS[56326] = Fluid3D([14881,14480,15319,15314],0); -ELEMENTS[56327] = Fluid3D([5354,5671,5845,5967],0); -ELEMENTS[56328] = Fluid3D([18130,18363,18264,18276],0); -ELEMENTS[56329] = Fluid3D([6457,6745,7040,7692],0); -ELEMENTS[56330] = Fluid3D([7870,7960,7984,6772],0); -ELEMENTS[56331] = Fluid3D([14691,14257,15193,14447],0); -ELEMENTS[56332] = Fluid3D([13056,13108,12743,11813],0); -ELEMENTS[56333] = Fluid3D([8364,8340,9341,8597],0); -ELEMENTS[56334] = Fluid3D([8364,8340,8597,7676],0); -ELEMENTS[56335] = Fluid3D([17499,17338,17848,17578],0); -ELEMENTS[56336] = Fluid3D([17499,17338,17578,17575],0); -ELEMENTS[56337] = Fluid3D([18459,18534,18564,18442],0); -ELEMENTS[56338] = Fluid3D([18459,18534,18442,18347],0); -ELEMENTS[56339] = Fluid3D([18534,18564,18442,18536],0); -ELEMENTS[56340] = Fluid3D([18564,18442,18536,18468],0); -ELEMENTS[56341] = Fluid3D([18442,18536,18468,18428],0); -ELEMENTS[56342] = Fluid3D([18564,18442,18468,18392],0); -ELEMENTS[56343] = Fluid3D([18442,18468,18392,18191],0); -ELEMENTS[56344] = Fluid3D([18442,18534,18536,18347],0); -ELEMENTS[56345] = Fluid3D([18536,18442,18347,18345],0); -ELEMENTS[56346] = Fluid3D([9597,9649,9474,8997],0); -ELEMENTS[56347] = Fluid3D([9597,9649,8997,8608],0); -ELEMENTS[56348] = Fluid3D([3879,4057,4105,4641],0); -ELEMENTS[56349] = Fluid3D([14775,14920,14807,14043],0); -ELEMENTS[56350] = Fluid3D([14109,14201,13895,13474],0); -ELEMENTS[56351] = Fluid3D([7124,6488,6321,6449],0); -ELEMENTS[56352] = Fluid3D([11775,11160,12544,11808],0); -ELEMENTS[56353] = Fluid3D([11775,11160,11808,10765],0); -ELEMENTS[56354] = Fluid3D([12544,11775,11808,12855],0); -ELEMENTS[56355] = Fluid3D([11808,12544,12855,11889],0); -ELEMENTS[56356] = Fluid3D([11775,11160,10765,10264],0); -ELEMENTS[56357] = Fluid3D([11808,11775,10765,11928],0); -ELEMENTS[56358] = Fluid3D([11808,11775,11928,12855],0); -ELEMENTS[56359] = Fluid3D([11928,11808,12855,12583],0); -ELEMENTS[56360] = Fluid3D([11160,10765,10264,11061],0); -ELEMENTS[56361] = Fluid3D([10120,10672,9615,9797],0); -ELEMENTS[56362] = Fluid3D([9582,9559,8469,8786],0); -ELEMENTS[56363] = Fluid3D([9559,8469,8786,8629],0); -ELEMENTS[56364] = Fluid3D([8786,9559,8629,9289],0); -ELEMENTS[56365] = Fluid3D([9582,9559,8786,9289],0); -ELEMENTS[56366] = Fluid3D([4199,4159,4240,4777],0); -ELEMENTS[56367] = Fluid3D([4240,4199,4777,5046],0); -ELEMENTS[56368] = Fluid3D([2250,2427,2390,2547],0); -ELEMENTS[56369] = Fluid3D([15936,15909,16368,16527],0); -ELEMENTS[56370] = Fluid3D([16368,15936,16527,16365],0); -ELEMENTS[56371] = Fluid3D([15931,15617,15854,15230],0); -ELEMENTS[56372] = Fluid3D([13374,13176,13558,12504],0); -ELEMENTS[56373] = Fluid3D([11871,11288,12381,12252],0); -ELEMENTS[56374] = Fluid3D([11288,12381,12252,11758],0); -ELEMENTS[56375] = Fluid3D([12381,12252,11758,12825],0); -ELEMENTS[56376] = Fluid3D([12252,11288,11758,10628],0); -ELEMENTS[56377] = Fluid3D([7545,7090,8062,8228],0); -ELEMENTS[56378] = Fluid3D([18662,18637,18643,18578],0); -ELEMENTS[56379] = Fluid3D([15109,15255,14396,15026],0); -ELEMENTS[56380] = Fluid3D([13730,13421,13366,12546],0); -ELEMENTS[56381] = Fluid3D([6659,7005,7618,6664],0); -ELEMENTS[56382] = Fluid3D([5922,6256,6639,5428],0); -ELEMENTS[56383] = Fluid3D([5048,4907,5571,5465],0); -ELEMENTS[56384] = Fluid3D([15574,15508,15718,14801],0); -ELEMENTS[56385] = Fluid3D([10260,9491,9387,9661],0); -ELEMENTS[56386] = Fluid3D([12739,12794,12415,13321],0); -ELEMENTS[56387] = Fluid3D([3843,3663,3900,4098],0); -ELEMENTS[56388] = Fluid3D([3423,3196,2989,3576],0); -ELEMENTS[56389] = Fluid3D([14550,14606,15433,15393],0); -ELEMENTS[56390] = Fluid3D([5130,4672,5093,5239],0); -ELEMENTS[56391] = Fluid3D([8927,9689,9822,10001],0); -ELEMENTS[56392] = Fluid3D([12021,12063,11209,10864],0); -ELEMENTS[56393] = Fluid3D([17884,17769,18012,17664],0); -ELEMENTS[56394] = Fluid3D([12001,11249,10968,11387],0); -ELEMENTS[56395] = Fluid3D([9481,9529,10116,10789],0); -ELEMENTS[56396] = Fluid3D([11447,12066,12057,12714],0); -ELEMENTS[56397] = Fluid3D([11076,11040,11984,10939],0); -ELEMENTS[56398] = Fluid3D([11811,11436,11023,10797],0); -ELEMENTS[56399] = Fluid3D([6190,5811,6713,6300],0); -ELEMENTS[56400] = Fluid3D([5811,6713,6300,6320],0); -ELEMENTS[56401] = Fluid3D([16807,16410,16674,16074],0); -ELEMENTS[56402] = Fluid3D([12093,12313,13058,12694],0); -ELEMENTS[56403] = Fluid3D([15787,15570,15277,16095],0); -ELEMENTS[56404] = Fluid3D([10830,11000,11671,10543],0); -ELEMENTS[56405] = Fluid3D([11910,10952,11389,11684],0); -ELEMENTS[56406] = Fluid3D([11389,11910,11684,12604],0); -ELEMENTS[56407] = Fluid3D([8541,9121,8139,9050],0); -ELEMENTS[56408] = Fluid3D([8541,9121,9050,9775],0); -ELEMENTS[56409] = Fluid3D([5009,5555,5026,4959],0); -ELEMENTS[56410] = Fluid3D([5009,5555,4959,5508],0); -ELEMENTS[56411] = Fluid3D([5026,5009,4959,4441],0); -ELEMENTS[56412] = Fluid3D([16299,16408,16305,15807],0); -ELEMENTS[56413] = Fluid3D([16305,16299,15807,16266],0); -ELEMENTS[56414] = Fluid3D([16299,15807,16266,15508],0); -ELEMENTS[56415] = Fluid3D([14577,14508,15030,14999],0); -ELEMENTS[56416] = Fluid3D([14577,14508,14999,14228],0); -ELEMENTS[56417] = Fluid3D([15030,14577,14999,15285],0); -ELEMENTS[56418] = Fluid3D([14577,14999,15285,14524],0); -ELEMENTS[56419] = Fluid3D([14577,14999,14524,14228],0); -ELEMENTS[56420] = Fluid3D([15285,14577,14524,14769],0); -ELEMENTS[56421] = Fluid3D([14524,14577,14228,13750],0); -ELEMENTS[56422] = Fluid3D([14524,14577,13750,14312],0); -ELEMENTS[56423] = Fluid3D([14524,14577,14312,14769],0); -ELEMENTS[56424] = Fluid3D([15030,14577,15285,14769],0); -ELEMENTS[56425] = Fluid3D([15030,14577,14769,14066],0); -ELEMENTS[56426] = Fluid3D([14577,14312,14769,13750],0); -ELEMENTS[56427] = Fluid3D([14577,14228,13750,14508],0); -ELEMENTS[56428] = Fluid3D([13358,12419,13270,13224],0); -ELEMENTS[56429] = Fluid3D([12575,12254,12566,11657],0); -ELEMENTS[56430] = Fluid3D([12254,12566,11657,11921],0); -ELEMENTS[56431] = Fluid3D([14448,13884,14600,14654],0); -ELEMENTS[56432] = Fluid3D([17691,17858,17707,17971],0); -ELEMENTS[56433] = Fluid3D([6853,7674,7302,6725],0); -ELEMENTS[56434] = Fluid3D([16714,16808,17193,17110],0); -ELEMENTS[56435] = Fluid3D([6588,6406,7241,7253],0); -ELEMENTS[56436] = Fluid3D([8104,7105,7495,7059],0); -ELEMENTS[56437] = Fluid3D([11785,12416,11990,12716],0); -ELEMENTS[56438] = Fluid3D([16030,15806,15339,16213],0); -ELEMENTS[56439] = Fluid3D([5776,6514,6099,5729],0); -ELEMENTS[56440] = Fluid3D([4318,4340,4267,4035],0); -ELEMENTS[56441] = Fluid3D([11692,11411,10811,11702],0); -ELEMENTS[56442] = Fluid3D([14754,15290,14606,15393],0); -ELEMENTS[56443] = Fluid3D([6304,5856,6576,6769],0); -ELEMENTS[56444] = Fluid3D([9824,10360,10745,9734],0); -ELEMENTS[56445] = Fluid3D([15625,15710,15221,15043],0); -ELEMENTS[56446] = Fluid3D([13863,13582,14164,14337],0); -ELEMENTS[56447] = Fluid3D([10696,11220,10658,11225],0); -ELEMENTS[56448] = Fluid3D([15173,15743,15832,15439],0); -ELEMENTS[56449] = Fluid3D([13850,14437,13738,13440],0); -ELEMENTS[56450] = Fluid3D([13738,13850,13440,12831],0); -ELEMENTS[56451] = Fluid3D([13440,13738,12831,12432],0); -ELEMENTS[56452] = Fluid3D([14437,13738,13440,13768],0); -ELEMENTS[56453] = Fluid3D([13738,13440,13768,13310],0); -ELEMENTS[56454] = Fluid3D([2681,2463,2503,2431],0); -ELEMENTS[56455] = Fluid3D([7037,6102,6808,6581],0); -ELEMENTS[56456] = Fluid3D([11097,10887,11769,11966],0); -ELEMENTS[56457] = Fluid3D([3789,4101,3927,4264],0); -ELEMENTS[56458] = Fluid3D([3927,3789,4264,4120],0); -ELEMENTS[56459] = Fluid3D([3789,4264,4120,4130],0); -ELEMENTS[56460] = Fluid3D([3789,4264,4130,4101],0); -ELEMENTS[56461] = Fluid3D([4264,4130,4101,4684],0); -ELEMENTS[56462] = Fluid3D([4101,3927,4264,4743],0); -ELEMENTS[56463] = Fluid3D([18393,18491,18483,18570],0); -ELEMENTS[56464] = Fluid3D([8056,7573,7803,7079],0); -ELEMENTS[56465] = Fluid3D([18679,18638,18648,18627],0); -ELEMENTS[56466] = Fluid3D([16182,16057,16666,16430],0); -ELEMENTS[56467] = Fluid3D([2686,2675,2944,2723],0); -ELEMENTS[56468] = Fluid3D([2686,2675,2723,2562],0); -ELEMENTS[56469] = Fluid3D([2686,2675,2562,2314],0); -ELEMENTS[56470] = Fluid3D([2723,2686,2562,2855],0); -ELEMENTS[56471] = Fluid3D([2686,2562,2855,2704],0); -ELEMENTS[56472] = Fluid3D([2686,2562,2704,2431],0); -ELEMENTS[56473] = Fluid3D([2562,2686,2314,2431],0); -ELEMENTS[56474] = Fluid3D([16009,15758,15628,16399],0); -ELEMENTS[56475] = Fluid3D([4337,4679,4343,4025],0); -ELEMENTS[56476] = Fluid3D([8386,8366,7974,7571],0); -ELEMENTS[56477] = Fluid3D([8366,7974,7571,7222],0); -ELEMENTS[56478] = Fluid3D([7571,8366,7222,7558],0); -ELEMENTS[56479] = Fluid3D([7222,7571,7558,7127],0); -ELEMENTS[56480] = Fluid3D([7222,7571,7127,7974],0); -ELEMENTS[56481] = Fluid3D([7571,7558,7127,8386],0); -ELEMENTS[56482] = Fluid3D([7571,7127,7974,8386],0); -ELEMENTS[56483] = Fluid3D([7571,7558,8386,8366],0); -ELEMENTS[56484] = Fluid3D([16581,16960,16449,16915],0); -ELEMENTS[56485] = Fluid3D([18689,18653,18678,18656],0); -ELEMENTS[56486] = Fluid3D([18653,18678,18656,18625],0); -ELEMENTS[56487] = Fluid3D([18678,18656,18625,18684],0); -ELEMENTS[56488] = Fluid3D([18678,18656,18684,18685],0); -ELEMENTS[56489] = Fluid3D([18684,18678,18685,18697],0); -ELEMENTS[56490] = Fluid3D([18678,18656,18685,18689],0); -ELEMENTS[56491] = Fluid3D([18685,18678,18689,18697],0); -ELEMENTS[56492] = Fluid3D([18689,18685,18697,18693],0); -ELEMENTS[56493] = Fluid3D([18684,18678,18697,18694],0); -ELEMENTS[56494] = Fluid3D([18684,18678,18694,18680],0); -ELEMENTS[56495] = Fluid3D([18684,18678,18680,18625],0); -ELEMENTS[56496] = Fluid3D([18685,18684,18697,18692],0); -ELEMENTS[56497] = Fluid3D([18697,18685,18692,18698],0); -ELEMENTS[56498] = Fluid3D([18689,18685,18693,18671],0); -ELEMENTS[56499] = Fluid3D([18685,18684,18692,18656],0); -ELEMENTS[56500] = Fluid3D([18689,18685,18671,18656],0); -ELEMENTS[56501] = Fluid3D([18685,18671,18656,18692],0); -ELEMENTS[56502] = Fluid3D([18685,18671,18692,18693],0); -ELEMENTS[56503] = Fluid3D([18685,18692,18698,18693],0); -ELEMENTS[56504] = Fluid3D([18697,18685,18698,18693],0); -ELEMENTS[56505] = Fluid3D([6220,5954,5885,6810],0); -ELEMENTS[56506] = Fluid3D([3909,3570,3547,4118],0); -ELEMENTS[56507] = Fluid3D([7340,7764,7711,8533],0); -ELEMENTS[56508] = Fluid3D([12875,13732,13463,13184],0); -ELEMENTS[56509] = Fluid3D([15860,15439,15107,15383],0); -ELEMENTS[56510] = Fluid3D([12054,12884,12549,12831],0); -ELEMENTS[56511] = Fluid3D([10790,11424,10029,10699],0); -ELEMENTS[56512] = Fluid3D([14649,14164,14849,14262],0); -ELEMENTS[56513] = Fluid3D([14164,14849,14262,13863],0); -ELEMENTS[56514] = Fluid3D([17257,17059,17087,17481],0); -ELEMENTS[56515] = Fluid3D([3779,3863,3423,3438],0); -ELEMENTS[56516] = Fluid3D([8606,8369,9338,8917],0); -ELEMENTS[56517] = Fluid3D([15234,14661,14560,14541],0); -ELEMENTS[56518] = Fluid3D([3639,4005,3819,3720],0); -ELEMENTS[56519] = Fluid3D([17177,17002,16698,16581],0); -ELEMENTS[56520] = Fluid3D([17002,16698,16581,16755],0); -ELEMENTS[56521] = Fluid3D([8643,8552,7706,8566],0); -ELEMENTS[56522] = Fluid3D([18361,18308,18221,18137],0); -ELEMENTS[56523] = Fluid3D([10492,11351,10456,10502],0); -ELEMENTS[56524] = Fluid3D([13273,13606,12908,13882],0); -ELEMENTS[56525] = Fluid3D([10303,10660,9533,9306],0); -ELEMENTS[56526] = Fluid3D([12772,12271,11666,11975],0); -ELEMENTS[56527] = Fluid3D([12772,12271,11975,12389],0); -ELEMENTS[56528] = Fluid3D([11666,12772,11975,12419],0); -ELEMENTS[56529] = Fluid3D([12271,11666,11975,11260],0); -ELEMENTS[56530] = Fluid3D([11975,12271,11260,12222],0); -ELEMENTS[56531] = Fluid3D([11666,11975,11260,10752],0); -ELEMENTS[56532] = Fluid3D([12271,11666,11260,11612],0); -ELEMENTS[56533] = Fluid3D([11666,11260,11612,10753],0); -ELEMENTS[56534] = Fluid3D([11666,11260,10753,10752],0); -ELEMENTS[56535] = Fluid3D([11260,10753,10752,11059],0); -ELEMENTS[56536] = Fluid3D([11260,10753,11059,11086],0); -ELEMENTS[56537] = Fluid3D([11260,11612,10753,11086],0); -ELEMENTS[56538] = Fluid3D([14709,14139,14273,14921],0); -ELEMENTS[56539] = Fluid3D([14709,14139,14921,15181],0); -ELEMENTS[56540] = Fluid3D([4160,3986,3874,3528],0); -ELEMENTS[56541] = Fluid3D([12506,11969,12670,11786],0); -ELEMENTS[56542] = Fluid3D([11969,12670,11786,12164],0); -ELEMENTS[56543] = Fluid3D([17648,17489,17867,17633],0); -ELEMENTS[56544] = Fluid3D([10432,11095,11570,10372],0); -ELEMENTS[56545] = Fluid3D([10483,9734,9927,9241],0); -ELEMENTS[56546] = Fluid3D([13222,13860,14201,13399],0); -ELEMENTS[56547] = Fluid3D([13117,12521,12277,13541],0); -ELEMENTS[56548] = Fluid3D([8869,9713,10020,9392],0); -ELEMENTS[56549] = Fluid3D([6719,6556,6879,5992],0); -ELEMENTS[56550] = Fluid3D([17170,17539,17420,17212],0); -ELEMENTS[56551] = Fluid3D([15445,15122,15468,16062],0); -ELEMENTS[56552] = Fluid3D([12251,12386,11573,12202],0); -ELEMENTS[56553] = Fluid3D([7954,7218,7951,7996],0); -ELEMENTS[56554] = Fluid3D([12232,12912,12727,13242],0); -ELEMENTS[56555] = Fluid3D([12232,12912,13242,12566],0); -ELEMENTS[56556] = Fluid3D([12232,12912,12566,13099],0); -ELEMENTS[56557] = Fluid3D([13242,12232,12566,11921],0); -ELEMENTS[56558] = Fluid3D([12232,12566,11921,11657],0); -ELEMENTS[56559] = Fluid3D([12232,12566,11657,12575],0); -ELEMENTS[56560] = Fluid3D([12232,12566,12575,13099],0); -ELEMENTS[56561] = Fluid3D([4039,4543,4206,4143],0); -ELEMENTS[56562] = Fluid3D([13511,12943,12633,12961],0); -ELEMENTS[56563] = Fluid3D([8325,8680,9448,8742],0); -ELEMENTS[56564] = Fluid3D([4612,4727,5097,5009],0); -ELEMENTS[56565] = Fluid3D([12747,12250,12243,13028],0); -ELEMENTS[56566] = Fluid3D([15999,15726,15786,16580],0); -ELEMENTS[56567] = Fluid3D([12870,13183,13011,12029],0); -ELEMENTS[56568] = Fluid3D([15037,14725,15326,15055],0); -ELEMENTS[56569] = Fluid3D([14626,14452,15072,14355],0); -ELEMENTS[56570] = Fluid3D([15072,14626,14355,14025],0); -ELEMENTS[56571] = Fluid3D([12588,11820,11978,11790],0); -ELEMENTS[56572] = Fluid3D([8230,7460,7778,8415],0); -ELEMENTS[56573] = Fluid3D([16415,16810,16787,16525],0); -ELEMENTS[56574] = Fluid3D([2142,2061,1938,1931],0); -ELEMENTS[56575] = Fluid3D([18423,18514,18581,18499],0); -ELEMENTS[56576] = Fluid3D([18423,18514,18499,18381],0); -ELEMENTS[56577] = Fluid3D([7786,7271,7471,6690],0); -ELEMENTS[56578] = Fluid3D([12060,11197,12283,11519],0); -ELEMENTS[56579] = Fluid3D([12283,12060,11519,12764],0); -ELEMENTS[56580] = Fluid3D([12283,12060,12764,13012],0); -ELEMENTS[56581] = Fluid3D([8916,9571,8615,9589],0); -ELEMENTS[56582] = Fluid3D([8916,9571,9589,10255],0); -ELEMENTS[56583] = Fluid3D([10109,9655,9857,8721],0); -ELEMENTS[56584] = Fluid3D([8913,8259,7841,8575],0); -ELEMENTS[56585] = Fluid3D([11748,11986,12644,13265],0); -ELEMENTS[56586] = Fluid3D([15396,15343,14642,14707],0); -ELEMENTS[56587] = Fluid3D([15343,14642,14707,14603],0); -ELEMENTS[56588] = Fluid3D([14642,14707,14603,13759],0); -ELEMENTS[56589] = Fluid3D([14603,13759,13947,14642],0); -ELEMENTS[56590] = Fluid3D([14069,14642,13947,13597],0); -ELEMENTS[56591] = Fluid3D([7724,7165,7477,6444],0); -ELEMENTS[56592] = Fluid3D([6006,5950,5378,5645],0); -ELEMENTS[56593] = Fluid3D([13785,14112,13313,13040],0); -ELEMENTS[56594] = Fluid3D([11116,11524,11103,10298],0); -ELEMENTS[56595] = Fluid3D([14594,14379,14291,15061],0); -ELEMENTS[56596] = Fluid3D([13077,13185,13677,13144],0); -ELEMENTS[56597] = Fluid3D([13185,13677,13144,14132],0); -ELEMENTS[56598] = Fluid3D([11643,10755,11189,10855],0); -ELEMENTS[56599] = Fluid3D([5129,5208,4821,4556],0); -ELEMENTS[56600] = Fluid3D([13273,12769,13797,13211],0); -ELEMENTS[56601] = Fluid3D([12244,12189,11128,12336],0); -ELEMENTS[56602] = Fluid3D([12244,12189,12336,13278],0); -ELEMENTS[56603] = Fluid3D([14209,13822,14030,13401],0); -ELEMENTS[56604] = Fluid3D([11829,11647,12248,10812],0); -ELEMENTS[56605] = Fluid3D([11829,11647,10812,10983],0); -ELEMENTS[56606] = Fluid3D([7214,7853,6926,7161],0); -ELEMENTS[56607] = Fluid3D([2357,2448,2727,2518],0); -ELEMENTS[56608] = Fluid3D([9906,10464,10524,11134],0); -ELEMENTS[56609] = Fluid3D([10652,10862,9583,10156],0); -ELEMENTS[56610] = Fluid3D([10652,10862,10156,10874],0); -ELEMENTS[56611] = Fluid3D([6270,5949,6457,6745],0); -ELEMENTS[56612] = Fluid3D([6457,6270,6745,7043],0); -ELEMENTS[56613] = Fluid3D([5949,6457,6745,5909],0); -ELEMENTS[56614] = Fluid3D([6745,6457,7043,7692],0); -ELEMENTS[56615] = Fluid3D([17172,17277,16854,16963],0); -ELEMENTS[56616] = Fluid3D([5173,5373,5165,4682],0); -ELEMENTS[56617] = Fluid3D([5173,5373,4682,4780],0); -ELEMENTS[56618] = Fluid3D([18054,18205,18324,18099],0); -ELEMENTS[56619] = Fluid3D([9936,8477,9333,8452],0); -ELEMENTS[56620] = Fluid3D([2260,2290,2537,2432],0); -ELEMENTS[56621] = Fluid3D([3520,3935,4057,3743],0); -ELEMENTS[56622] = Fluid3D([14567,14864,14736,15447],0); -ELEMENTS[56623] = Fluid3D([12474,13157,13633,12876],0); -ELEMENTS[56624] = Fluid3D([11064,11103,11524,10298],0); -ELEMENTS[56625] = Fluid3D([13303,13924,13252,13100],0); -ELEMENTS[56626] = Fluid3D([11097,10868,10007,10263],0); -ELEMENTS[56627] = Fluid3D([12369,13300,13282,12667],0); -ELEMENTS[56628] = Fluid3D([16046,15474,16038,15638],0); -ELEMENTS[56629] = Fluid3D([17187,17478,17120,16950],0); -ELEMENTS[56630] = Fluid3D([15488,15853,15943,15370],0); -ELEMENTS[56631] = Fluid3D([14372,14270,14081,15149],0); -ELEMENTS[56632] = Fluid3D([9215,10023,9587,9096],0); -ELEMENTS[56633] = Fluid3D([17273,16947,17342,17264],0); -ELEMENTS[56634] = Fluid3D([3669,3499,3444,3098],0); -ELEMENTS[56635] = Fluid3D([12503,12959,12252,12938],0); -ELEMENTS[56636] = Fluid3D([12503,12959,12938,13665],0); -ELEMENTS[56637] = Fluid3D([12959,12252,12938,12825],0); -ELEMENTS[56638] = Fluid3D([12959,12938,13665,13398],0); -ELEMENTS[56639] = Fluid3D([12938,13665,13398,13084],0); -ELEMENTS[56640] = Fluid3D([12938,13665,13084,12503],0); -ELEMENTS[56641] = Fluid3D([13084,12938,12503,12082],0); -ELEMENTS[56642] = Fluid3D([13398,12938,13084,12989],0); -ELEMENTS[56643] = Fluid3D([12938,13084,12989,12381],0); -ELEMENTS[56644] = Fluid3D([13398,12938,12989,12381],0); -ELEMENTS[56645] = Fluid3D([13398,12938,12381,12825],0); -ELEMENTS[56646] = Fluid3D([13665,13398,13084,13958],0); -ELEMENTS[56647] = Fluid3D([13398,12938,12825,12959],0); -ELEMENTS[56648] = Fluid3D([12938,12381,12825,12252],0); -ELEMENTS[56649] = Fluid3D([12938,12381,12252,12503],0); -ELEMENTS[56650] = Fluid3D([13665,13398,13958,14331],0); -ELEMENTS[56651] = Fluid3D([12938,13084,12381,12332],0); -ELEMENTS[56652] = Fluid3D([12938,13084,12332,12082],0); -ELEMENTS[56653] = Fluid3D([12381,12938,12332,11871],0); -ELEMENTS[56654] = Fluid3D([13665,13084,12503,14096],0); -ELEMENTS[56655] = Fluid3D([13665,13084,14096,13817],0); -ELEMENTS[56656] = Fluid3D([13665,13084,13817,13958],0); -ELEMENTS[56657] = Fluid3D([13084,14096,13817,12894],0); -ELEMENTS[56658] = Fluid3D([13665,13398,14331,13786],0); -ELEMENTS[56659] = Fluid3D([13665,13398,13786,12959],0); -ELEMENTS[56660] = Fluid3D([12886,13322,13136,12288],0); -ELEMENTS[56661] = Fluid3D([4064,4489,4015,4305],0); -ELEMENTS[56662] = Fluid3D([6980,7769,7869,6813],0); -ELEMENTS[56663] = Fluid3D([4750,4473,5017,5152],0); -ELEMENTS[56664] = Fluid3D([4473,5017,5152,4731],0); -ELEMENTS[56665] = Fluid3D([5017,5152,4731,5583],0); -ELEMENTS[56666] = Fluid3D([5017,5152,5583,5757],0); -ELEMENTS[56667] = Fluid3D([15770,16023,16358,15502],0); -ELEMENTS[56668] = Fluid3D([9469,9876,10818,9919],0); -ELEMENTS[56669] = Fluid3D([9079,8977,9226,8208],0); -ELEMENTS[56670] = Fluid3D([18450,18501,18561,18586],0); -ELEMENTS[56671] = Fluid3D([11887,11725,12658,11395],0); -ELEMENTS[56672] = Fluid3D([2056,1942,2163,2198],0); -ELEMENTS[56673] = Fluid3D([13755,13851,14514,13866],0); -ELEMENTS[56674] = Fluid3D([8541,8085,8551,9002],0); -ELEMENTS[56675] = Fluid3D([8085,8551,9002,8525],0); -ELEMENTS[56676] = Fluid3D([8085,8551,8525,7673],0); -ELEMENTS[56677] = Fluid3D([3132,3075,3142,2826],0); -ELEMENTS[56678] = Fluid3D([3132,3075,2826,2777],0); -ELEMENTS[56679] = Fluid3D([3132,3075,2777,2957],0); -ELEMENTS[56680] = Fluid3D([17140,16950,16705,17138],0); -ELEMENTS[56681] = Fluid3D([17140,16950,17138,17430],0); -ELEMENTS[56682] = Fluid3D([16667,17014,16504,16898],0); -ELEMENTS[56683] = Fluid3D([18081,18240,18098,17875],0); -ELEMENTS[56684] = Fluid3D([2980,3176,2920,2701],0); -ELEMENTS[56685] = Fluid3D([11748,12387,11986,13265],0); -ELEMENTS[56686] = Fluid3D([6224,5663,6346,6233],0); -ELEMENTS[56687] = Fluid3D([18188,18338,18403,18273],0); -ELEMENTS[56688] = Fluid3D([11223,11809,11566,11022],0); -ELEMENTS[56689] = Fluid3D([9365,9242,8597,7969],0); -ELEMENTS[56690] = Fluid3D([18122,18310,18139,18215],0); -ELEMENTS[56691] = Fluid3D([18122,18310,18215,18378],0); -ELEMENTS[56692] = Fluid3D([2289,2222,2152,2037],0); -ELEMENTS[56693] = Fluid3D([2654,2390,2427,2547],0); -ELEMENTS[56694] = Fluid3D([12012,12475,11632,13003],0); -ELEMENTS[56695] = Fluid3D([16335,15969,16396,16020],0); -ELEMENTS[56696] = Fluid3D([16335,15969,16020,15692],0); -ELEMENTS[56697] = Fluid3D([16396,16335,16020,16407],0); -ELEMENTS[56698] = Fluid3D([15969,16396,16020,15572],0); -ELEMENTS[56699] = Fluid3D([16020,16396,16407,15870],0); -ELEMENTS[56700] = Fluid3D([16020,16396,15870,15572],0); -ELEMENTS[56701] = Fluid3D([16407,16020,15870,15432],0); -ELEMENTS[56702] = Fluid3D([16020,15870,15432,15572],0); -ELEMENTS[56703] = Fluid3D([15870,15432,15572,15267],0); -ELEMENTS[56704] = Fluid3D([15870,15432,15267,15865],0); -ELEMENTS[56705] = Fluid3D([15870,15432,15865,15740],0); -ELEMENTS[56706] = Fluid3D([15865,15870,15740,16243],0); -ELEMENTS[56707] = Fluid3D([15865,15870,16243,16396],0); -ELEMENTS[56708] = Fluid3D([15870,15432,15740,16407],0); -ELEMENTS[56709] = Fluid3D([15740,15865,16243,16584],0); -ELEMENTS[56710] = Fluid3D([15870,15740,16243,16407],0); -ELEMENTS[56711] = Fluid3D([16243,15870,16407,16396],0); -ELEMENTS[56712] = Fluid3D([15432,15865,15740,15267],0); -ELEMENTS[56713] = Fluid3D([15865,16243,16584,16509],0); -ELEMENTS[56714] = Fluid3D([15865,16243,16509,16396],0); -ELEMENTS[56715] = Fluid3D([16243,15740,16584,15970],0); -ELEMENTS[56716] = Fluid3D([16243,15740,15970,16407],0); -ELEMENTS[56717] = Fluid3D([15970,16243,16407,16584],0); -ELEMENTS[56718] = Fluid3D([16243,16407,16584,16509],0); -ELEMENTS[56719] = Fluid3D([15865,15870,16396,15572],0); -ELEMENTS[56720] = Fluid3D([16407,16243,16396,16509],0); -ELEMENTS[56721] = Fluid3D([11881,12733,12647,12459],0); -ELEMENTS[56722] = Fluid3D([7127,6505,7222,7669],0); -ELEMENTS[56723] = Fluid3D([16426,15783,15834,15877],0); -ELEMENTS[56724] = Fluid3D([2514,2553,2378,2872],0); -ELEMENTS[56725] = Fluid3D([16459,16898,16371,16504],0); -ELEMENTS[56726] = Fluid3D([10243,10688,10252,11608],0); -ELEMENTS[56727] = Fluid3D([5679,6198,5648,5442],0); -ELEMENTS[56728] = Fluid3D([15212,15733,15169,15300],0); -ELEMENTS[56729] = Fluid3D([8779,8225,8090,7647],0); -ELEMENTS[56730] = Fluid3D([9268,8841,8233,8822],0); -ELEMENTS[56731] = Fluid3D([4590,4911,5131,4476],0); -ELEMENTS[56732] = Fluid3D([7225,6605,6923,7728],0); -ELEMENTS[56733] = Fluid3D([7844,7818,8770,8323],0); -ELEMENTS[56734] = Fluid3D([13511,14255,14159,13720],0); -ELEMENTS[56735] = Fluid3D([13780,14231,13232,14268],0); -ELEMENTS[56736] = Fluid3D([5237,4638,5276,4832],0); -ELEMENTS[56737] = Fluid3D([4705,4461,4144,4240],0); -ELEMENTS[56738] = Fluid3D([8740,8792,8844,8222],0); -ELEMENTS[56739] = Fluid3D([6373,6604,6405,5898],0); -ELEMENTS[56740] = Fluid3D([6405,6373,5898,6590],0); -ELEMENTS[56741] = Fluid3D([15637,15075,15669,15346],0); -ELEMENTS[56742] = Fluid3D([10709,11006,9828,10676],0); -ELEMENTS[56743] = Fluid3D([10709,11006,10676,11206],0); -ELEMENTS[56744] = Fluid3D([11006,9828,10676,10422],0); -ELEMENTS[56745] = Fluid3D([10676,11006,10422,11770],0); -ELEMENTS[56746] = Fluid3D([11006,10676,11206,11770],0); -ELEMENTS[56747] = Fluid3D([9828,10676,10422,9225],0); -ELEMENTS[56748] = Fluid3D([9828,10709,10676,9793],0); -ELEMENTS[56749] = Fluid3D([10676,9828,9793,9225],0); -ELEMENTS[56750] = Fluid3D([9828,10709,9793,10357],0); -ELEMENTS[56751] = Fluid3D([10709,10676,9793,10238],0); -ELEMENTS[56752] = Fluid3D([9828,9793,9225,8784],0); -ELEMENTS[56753] = Fluid3D([9828,9793,8784,8846],0); -ELEMENTS[56754] = Fluid3D([10676,9793,10238,9225],0); -ELEMENTS[56755] = Fluid3D([9225,9828,8784,9421],0); -ELEMENTS[56756] = Fluid3D([4542,4816,4212,4494],0); -ELEMENTS[56757] = Fluid3D([4542,4816,4494,5112],0); -ELEMENTS[56758] = Fluid3D([10900,9827,10593,9847],0); -ELEMENTS[56759] = Fluid3D([5423,5305,5278,4730],0); -ELEMENTS[56760] = Fluid3D([8431,8814,8336,7938],0); -ELEMENTS[56761] = Fluid3D([7543,7016,6449,7124],0); -ELEMENTS[56762] = Fluid3D([5498,5292,5186,4805],0); -ELEMENTS[56763] = Fluid3D([5737,5317,5796,5121],0); -ELEMENTS[56764] = Fluid3D([14139,13655,14140,14569],0); -ELEMENTS[56765] = Fluid3D([17925,17616,17607,17704],0); -ELEMENTS[56766] = Fluid3D([17925,17616,17704,18004],0); -ELEMENTS[56767] = Fluid3D([17616,17607,17704,17317],0); -ELEMENTS[56768] = Fluid3D([17616,17704,18004,17720],0); -ELEMENTS[56769] = Fluid3D([17616,17704,17720,17333],0); -ELEMENTS[56770] = Fluid3D([17616,17704,17333,17317],0); -ELEMENTS[56771] = Fluid3D([13798,13818,12704,13085],0); -ELEMENTS[56772] = Fluid3D([12704,13798,13085,13758],0); -ELEMENTS[56773] = Fluid3D([13607,14198,13331,13817],0); -ELEMENTS[56774] = Fluid3D([5380,5522,4920,5433],0); -ELEMENTS[56775] = Fluid3D([13693,14366,14596,13578],0); -ELEMENTS[56776] = Fluid3D([13320,12933,13196,12040],0); -ELEMENTS[56777] = Fluid3D([5794,5139,5695,5507],0); -ELEMENTS[56778] = Fluid3D([9723,9385,10157,10293],0); -ELEMENTS[56779] = Fluid3D([17350,17467,17749,17381],0); -ELEMENTS[56780] = Fluid3D([5282,5068,5603,5522],0); -ELEMENTS[56781] = Fluid3D([17012,17412,17216,17241],0); -ELEMENTS[56782] = Fluid3D([17216,17012,17241,16757],0); -ELEMENTS[56783] = Fluid3D([17012,17412,17241,17502],0); -ELEMENTS[56784] = Fluid3D([11215,11941,11777,11593],0); -ELEMENTS[56785] = Fluid3D([7085,7264,6375,6637],0); -ELEMENTS[56786] = Fluid3D([6375,7085,6637,6119],0); -ELEMENTS[56787] = Fluid3D([1870,1786,1677,1785],0); -ELEMENTS[56788] = Fluid3D([5086,4922,4892,4357],0); -ELEMENTS[56789] = Fluid3D([12246,11478,11887,12658],0); -ELEMENTS[56790] = Fluid3D([12481,11499,12414,12047],0); -ELEMENTS[56791] = Fluid3D([3387,3347,3802,3128],0); -ELEMENTS[56792] = Fluid3D([15947,16116,15344,15636],0); -ELEMENTS[56793] = Fluid3D([3670,3769,3246,3553],0); -ELEMENTS[56794] = Fluid3D([9618,9564,10621,10037],0); -ELEMENTS[56795] = Fluid3D([15320,15164,14539,14397],0); -ELEMENTS[56796] = Fluid3D([15655,15217,15906,16077],0); -ELEMENTS[56797] = Fluid3D([8068,8507,8858,7745],0); -ELEMENTS[56798] = Fluid3D([18034,18199,18301,18116],0); -ELEMENTS[56799] = Fluid3D([18034,18199,18116,18006],0); -ELEMENTS[56800] = Fluid3D([18034,18199,18006,18106],0); -ELEMENTS[56801] = Fluid3D([17772,17871,17870,18059],0); -ELEMENTS[56802] = Fluid3D([17870,17772,18059,18046],0); -ELEMENTS[56803] = Fluid3D([17772,17871,18059,17770],0); -ELEMENTS[56804] = Fluid3D([7200,6893,6862,6868],0); -ELEMENTS[56805] = Fluid3D([2739,2745,2970,3123],0); -ELEMENTS[56806] = Fluid3D([2745,2970,3123,3127],0); -ELEMENTS[56807] = Fluid3D([18050,17788,17653,17933],0); -ELEMENTS[56808] = Fluid3D([8365,8669,9093,8852],0); -ELEMENTS[56809] = Fluid3D([3208,3522,3178,3082],0); -ELEMENTS[56810] = Fluid3D([5615,5187,4993,5352],0); -ELEMENTS[56811] = Fluid3D([16032,16340,15864,16510],0); -ELEMENTS[56812] = Fluid3D([16032,16340,16510,16783],0); -ELEMENTS[56813] = Fluid3D([15930,16089,15490,15539],0); -ELEMENTS[56814] = Fluid3D([7567,6999,7903,7355],0); -ELEMENTS[56815] = Fluid3D([7567,6999,7355,6627],0); -ELEMENTS[56816] = Fluid3D([16436,15848,16099,15893],0); -ELEMENTS[56817] = Fluid3D([18023,18058,18265,18254],0); -ELEMENTS[56818] = Fluid3D([16101,15849,15814,16590],0); -ELEMENTS[56819] = Fluid3D([7845,7587,7507,8453],0); -ELEMENTS[56820] = Fluid3D([15737,16024,15736,16278],0); -ELEMENTS[56821] = Fluid3D([16024,15736,16278,15668],0); -ELEMENTS[56822] = Fluid3D([16278,16024,15668,16149],0); -ELEMENTS[56823] = Fluid3D([15737,16024,16278,16601],0); -ELEMENTS[56824] = Fluid3D([15736,16278,15668,16195],0); -ELEMENTS[56825] = Fluid3D([13265,12390,12387,11986],0); -ELEMENTS[56826] = Fluid3D([12390,12387,11986,11992],0); -ELEMENTS[56827] = Fluid3D([13265,12390,11986,13196],0); -ELEMENTS[56828] = Fluid3D([13942,14253,13430,14538],0); -ELEMENTS[56829] = Fluid3D([13942,14253,14538,14892],0); -ELEMENTS[56830] = Fluid3D([11160,10463,10264,11775],0); -ELEMENTS[56831] = Fluid3D([10791,10436,10398,9392],0); -ELEMENTS[56832] = Fluid3D([11363,10623,11739,11002],0); -ELEMENTS[56833] = Fluid3D([11087,11317,11373,10287],0); -ELEMENTS[56834] = Fluid3D([4057,3879,4538,4641],0); -ELEMENTS[56835] = Fluid3D([10293,10833,9710,10336],0); -ELEMENTS[56836] = Fluid3D([9207,8877,9108,8209],0); -ELEMENTS[56837] = Fluid3D([9328,8666,9741,10048],0); -ELEMENTS[56838] = Fluid3D([9741,9328,10048,10753],0); -ELEMENTS[56839] = Fluid3D([13149,13334,13160,12268],0); -ELEMENTS[56840] = Fluid3D([10185,9191,9420,8961],0); -ELEMENTS[56841] = Fluid3D([4663,4946,4606,4293],0); -ELEMENTS[56842] = Fluid3D([8290,7578,8650,7971],0); -ELEMENTS[56843] = Fluid3D([8650,8290,7971,8851],0); -ELEMENTS[56844] = Fluid3D([7578,8650,7971,7431],0); -ELEMENTS[56845] = Fluid3D([7971,8650,8851,8747],0); -ELEMENTS[56846] = Fluid3D([7373,6808,7275,6758],0); -ELEMENTS[56847] = Fluid3D([7275,7373,6758,7051],0); -ELEMENTS[56848] = Fluid3D([7373,6808,6758,6816],0); -ELEMENTS[56849] = Fluid3D([6758,7373,6816,7624],0); -ELEMENTS[56850] = Fluid3D([6808,6758,6816,6078],0); -ELEMENTS[56851] = Fluid3D([7373,6758,7051,7624],0); -ELEMENTS[56852] = Fluid3D([6816,6808,6078,6581],0); -ELEMENTS[56853] = Fluid3D([6758,6816,6078,6266],0); -ELEMENTS[56854] = Fluid3D([6758,6816,6266,7051],0); -ELEMENTS[56855] = Fluid3D([6266,6758,7051,6503],0); -ELEMENTS[56856] = Fluid3D([6758,6816,7051,7624],0); -ELEMENTS[56857] = Fluid3D([6078,6758,6266,6338],0); -ELEMENTS[56858] = Fluid3D([6758,6266,6338,6639],0); -ELEMENTS[56859] = Fluid3D([6266,6078,6338,5649],0); -ELEMENTS[56860] = Fluid3D([6338,6266,5649,5834],0); -ELEMENTS[56861] = Fluid3D([6266,6758,6503,6639],0); -ELEMENTS[56862] = Fluid3D([6808,6078,6581,6102],0); -ELEMENTS[56863] = Fluid3D([6758,7051,6503,6639],0); -ELEMENTS[56864] = Fluid3D([6816,6808,6581,7502],0); -ELEMENTS[56865] = Fluid3D([8065,7867,7119,6978],0); -ELEMENTS[56866] = Fluid3D([7870,8396,7641,7368],0); -ELEMENTS[56867] = Fluid3D([14657,14414,14531,15261],0); -ELEMENTS[56868] = Fluid3D([11876,10852,11322,11220],0); -ELEMENTS[56869] = Fluid3D([18252,18464,18363,18287],0); -ELEMENTS[56870] = Fluid3D([10755,10817,9773,9965],0); -ELEMENTS[56871] = Fluid3D([5129,5052,5095,4569],0); -ELEMENTS[56872] = Fluid3D([13442,13985,14039,14249],0); -ELEMENTS[56873] = Fluid3D([13985,14039,14249,14946],0); -ELEMENTS[56874] = Fluid3D([13442,13985,14249,13914],0); -ELEMENTS[56875] = Fluid3D([14904,15514,15458,15394],0); -ELEMENTS[56876] = Fluid3D([12224,11769,12592,12932],0); -ELEMENTS[56877] = Fluid3D([18329,18232,18206,18011],0); -ELEMENTS[56878] = Fluid3D([10769,10766,9628,9931],0); -ELEMENTS[56879] = Fluid3D([10766,9628,9931,9017],0); -ELEMENTS[56880] = Fluid3D([11458,10926,10960,12310],0); -ELEMENTS[56881] = Fluid3D([6449,5857,6488,6321],0); -ELEMENTS[56882] = Fluid3D([5710,5358,5738,5385],0); -ELEMENTS[56883] = Fluid3D([9809,10601,10401,9850],0); -ELEMENTS[56884] = Fluid3D([10601,10401,9850,10790],0); -ELEMENTS[56885] = Fluid3D([9850,10601,10790,10699],0); -ELEMENTS[56886] = Fluid3D([5555,5300,5051,5704],0); -ELEMENTS[56887] = Fluid3D([18078,18295,18373,18158],0); -ELEMENTS[56888] = Fluid3D([16408,16089,16305,15807],0); -ELEMENTS[56889] = Fluid3D([12866,13003,12012,12407],0); -ELEMENTS[56890] = Fluid3D([12866,13003,12407,12875],0); -ELEMENTS[56891] = Fluid3D([12407,12866,12875,12044],0); -ELEMENTS[56892] = Fluid3D([13003,12407,12875,12684],0); -ELEMENTS[56893] = Fluid3D([12012,12866,12407,12044],0); -ELEMENTS[56894] = Fluid3D([13003,12012,12407,11632],0); -ELEMENTS[56895] = Fluid3D([2527,2292,2440,2531],0); -ELEMENTS[56896] = Fluid3D([11237,10478,10627,10021],0); -ELEMENTS[56897] = Fluid3D([7775,8295,8610,7952],0); -ELEMENTS[56898] = Fluid3D([6445,6747,7063,7167],0); -ELEMENTS[56899] = Fluid3D([7063,6445,7167,6639],0); -ELEMENTS[56900] = Fluid3D([7167,7063,6639,7623],0); -ELEMENTS[56901] = Fluid3D([4849,5459,5261,5605],0); -ELEMENTS[56902] = Fluid3D([17785,17649,17372,17384],0); -ELEMENTS[56903] = Fluid3D([10978,10462,9466,9544],0); -ELEMENTS[56904] = Fluid3D([11622,11519,10681,10920],0); -ELEMENTS[56905] = Fluid3D([11622,11519,10920,11708],0); -ELEMENTS[56906] = Fluid3D([7951,7996,8556,7954],0); -ELEMENTS[56907] = Fluid3D([8556,7951,7954,8591],0); -ELEMENTS[56908] = Fluid3D([7954,8556,8591,8773],0); -ELEMENTS[56909] = Fluid3D([7954,8556,8773,8792],0); -ELEMENTS[56910] = Fluid3D([7996,8556,7954,7609],0); -ELEMENTS[56911] = Fluid3D([15229,15345,15381,15779],0); -ELEMENTS[56912] = Fluid3D([12496,12002,12998,12751],0); -ELEMENTS[56913] = Fluid3D([12002,12998,12751,12026],0); -ELEMENTS[56914] = Fluid3D([12998,12496,12751,13494],0); -ELEMENTS[56915] = Fluid3D([12751,12998,13494,13249],0); -ELEMENTS[56916] = Fluid3D([12751,12998,13249,12464],0); -ELEMENTS[56917] = Fluid3D([12998,13494,13249,13891],0); -ELEMENTS[56918] = Fluid3D([13249,12998,13891,13382],0); -ELEMENTS[56919] = Fluid3D([12998,13494,13891,13382],0); -ELEMENTS[56920] = Fluid3D([4713,5286,5320,5495],0); -ELEMENTS[56921] = Fluid3D([5286,5320,5495,5946],0); -ELEMENTS[56922] = Fluid3D([16667,17046,17163,17031],0); -ELEMENTS[56923] = Fluid3D([4625,5143,4486,4592],0); -ELEMENTS[56924] = Fluid3D([4625,5143,4592,5100],0); -ELEMENTS[56925] = Fluid3D([4486,4625,4592,3984],0); -ELEMENTS[56926] = Fluid3D([4625,4592,3984,4356],0); -ELEMENTS[56927] = Fluid3D([4625,4592,4356,5100],0); -ELEMENTS[56928] = Fluid3D([10774,10359,10135,9502],0); -ELEMENTS[56929] = Fluid3D([18659,18642,18586,18665],0); -ELEMENTS[56930] = Fluid3D([18659,18642,18665,18687],0); -ELEMENTS[56931] = Fluid3D([18642,18665,18687,18667],0); -ELEMENTS[56932] = Fluid3D([18665,18687,18667,18663],0); -ELEMENTS[56933] = Fluid3D([4997,5285,4830,5243],0); -ELEMENTS[56934] = Fluid3D([10105,9652,10825,9832],0); -ELEMENTS[56935] = Fluid3D([5250,4840,5494,5572],0); -ELEMENTS[56936] = Fluid3D([11728,11730,12647,12979],0); -ELEMENTS[56937] = Fluid3D([9421,8821,8494,8784],0); -ELEMENTS[56938] = Fluid3D([13816,13775,13637,12801],0); -ELEMENTS[56939] = Fluid3D([12629,12177,12093,11405],0); -ELEMENTS[56940] = Fluid3D([11022,11129,11566,10587],0); -ELEMENTS[56941] = Fluid3D([3760,3805,3890,4521],0); -ELEMENTS[56942] = Fluid3D([11884,12808,12280,13017],0); -ELEMENTS[56943] = Fluid3D([4182,3738,4125,3945],0); -ELEMENTS[56944] = Fluid3D([7866,8314,8417,9001],0); -ELEMENTS[56945] = Fluid3D([8417,7866,9001,8751],0); -ELEMENTS[56946] = Fluid3D([9903,10152,9456,10629],0); -ELEMENTS[56947] = Fluid3D([6788,6005,6495,6476],0); -ELEMENTS[56948] = Fluid3D([14085,14374,14358,15077],0); -ELEMENTS[56949] = Fluid3D([17189,17510,17377,17566],0); -ELEMENTS[56950] = Fluid3D([14009,14128,13245,13812],0); -ELEMENTS[56951] = Fluid3D([16288,16022,15878,16565],0); -ELEMENTS[56952] = Fluid3D([9977,9411,9981,9237],0); -ELEMENTS[56953] = Fluid3D([13430,13408,13942,14538],0); -ELEMENTS[56954] = Fluid3D([16817,16673,16336,16733],0); -ELEMENTS[56955] = Fluid3D([7305,7150,6537,7357],0); -ELEMENTS[56956] = Fluid3D([12577,12118,12175,11516],0); -ELEMENTS[56957] = Fluid3D([12577,12118,11516,12332],0); -ELEMENTS[56958] = Fluid3D([7786,8193,7244,7447],0); -ELEMENTS[56959] = Fluid3D([4165,3932,3818,3603],0); -ELEMENTS[56960] = Fluid3D([8032,8206,7274,7594],0); -ELEMENTS[56961] = Fluid3D([8032,8206,7594,8426],0); -ELEMENTS[56962] = Fluid3D([8032,8206,8426,8946],0); -ELEMENTS[56963] = Fluid3D([8032,8206,8946,8682],0); -ELEMENTS[56964] = Fluid3D([8426,8032,8946,8623],0); -ELEMENTS[56965] = Fluid3D([8032,8946,8623,8682],0); -ELEMENTS[56966] = Fluid3D([12822,12992,12569,13673],0); -ELEMENTS[56967] = Fluid3D([12992,12569,13673,13451],0); -ELEMENTS[56968] = Fluid3D([13673,12992,13451,12822],0); -ELEMENTS[56969] = Fluid3D([9419,10465,10336,9710],0); -ELEMENTS[56970] = Fluid3D([9396,9110,8345,9477],0); -ELEMENTS[56971] = Fluid3D([16240,16768,16252,16674],0); -ELEMENTS[56972] = Fluid3D([17328,16793,17408,17056],0); -ELEMENTS[56973] = Fluid3D([16892,16404,16561,16741],0); -ELEMENTS[56974] = Fluid3D([6297,6161,5788,5453],0); -ELEMENTS[56975] = Fluid3D([17054,16863,17312,16894],0); -ELEMENTS[56976] = Fluid3D([13741,13999,13276,14275],0); -ELEMENTS[56977] = Fluid3D([11981,11073,11064,10954],0); -ELEMENTS[56978] = Fluid3D([11981,11073,10954,11671],0); -ELEMENTS[56979] = Fluid3D([11073,11064,10954,10219],0); -ELEMENTS[56980] = Fluid3D([11064,10954,10219,11267],0); -ELEMENTS[56981] = Fluid3D([10219,11064,11267,10587],0); -ELEMENTS[56982] = Fluid3D([11064,11267,10587,11524],0); -ELEMENTS[56983] = Fluid3D([11267,10219,10587,10390],0); -ELEMENTS[56984] = Fluid3D([11064,10954,11267,11981],0); -ELEMENTS[56985] = Fluid3D([11267,11064,11981,12127],0); -ELEMENTS[56986] = Fluid3D([11267,11064,12127,11524],0); -ELEMENTS[56987] = Fluid3D([10219,11064,10587,10194],0); -ELEMENTS[56988] = Fluid3D([10219,11064,10194,11073],0); -ELEMENTS[56989] = Fluid3D([10954,10219,11267,10390],0); -ELEMENTS[56990] = Fluid3D([7069,6875,6590,7493],0); -ELEMENTS[56991] = Fluid3D([12792,12924,12723,13579],0); -ELEMENTS[56992] = Fluid3D([5242,5183,4711,5113],0); -ELEMENTS[56993] = Fluid3D([15880,16006,16483,16293],0); -ELEMENTS[56994] = Fluid3D([13530,13444,13773,14206],0); -ELEMENTS[56995] = Fluid3D([13530,13444,14206,13959],0); -ELEMENTS[56996] = Fluid3D([13444,14206,13959,13773],0); -ELEMENTS[56997] = Fluid3D([13530,13444,13959,14106],0); -ELEMENTS[56998] = Fluid3D([13149,12794,13807,13321],0); -ELEMENTS[56999] = Fluid3D([4205,4416,4273,3861],0); -ELEMENTS[57000] = Fluid3D([4205,4416,3861,3962],0); -ELEMENTS[57001] = Fluid3D([4273,4205,3861,4089],0); -ELEMENTS[57002] = Fluid3D([11952,11284,10778,11583],0); -ELEMENTS[57003] = Fluid3D([11952,11284,11583,12273],0); -ELEMENTS[57004] = Fluid3D([11284,11583,12273,11104],0); -ELEMENTS[57005] = Fluid3D([11583,12273,11104,11996],0); -ELEMENTS[57006] = Fluid3D([11583,11952,12273,12652],0); -ELEMENTS[57007] = Fluid3D([11284,10778,11583,11104],0); -ELEMENTS[57008] = Fluid3D([10778,11583,11104,11996],0); -ELEMENTS[57009] = Fluid3D([10778,11952,11583,11894],0); -ELEMENTS[57010] = Fluid3D([9945,9035,9488,8895],0); -ELEMENTS[57011] = Fluid3D([5993,6575,6677,6619],0); -ELEMENTS[57012] = Fluid3D([6575,6677,6619,7326],0); -ELEMENTS[57013] = Fluid3D([6677,6619,7326,6921],0); -ELEMENTS[57014] = Fluid3D([6677,6619,6921,6261],0); -ELEMENTS[57015] = Fluid3D([8536,9322,9073,9788],0); -ELEMENTS[57016] = Fluid3D([4295,3940,4429,3933],0); -ELEMENTS[57017] = Fluid3D([17770,17959,18023,18071],0); -ELEMENTS[57018] = Fluid3D([14161,14261,14720,15185],0); -ELEMENTS[57019] = Fluid3D([11954,12419,12640,11666],0); -ELEMENTS[57020] = Fluid3D([13888,13014,13556,13784],0); -ELEMENTS[57021] = Fluid3D([7467,7368,7984,6772],0); -ELEMENTS[57022] = Fluid3D([14545,13878,14537,14108],0); -ELEMENTS[57023] = Fluid3D([14508,14631,15239,15101],0); -ELEMENTS[57024] = Fluid3D([14508,14631,15101,13952],0); -ELEMENTS[57025] = Fluid3D([14631,15239,15101,15292],0); -ELEMENTS[57026] = Fluid3D([15101,14631,15292,14947],0); -ELEMENTS[57027] = Fluid3D([15101,14631,14947,13952],0); -ELEMENTS[57028] = Fluid3D([15292,15101,14947,15404],0); -ELEMENTS[57029] = Fluid3D([15101,14947,15404,15218],0); -ELEMENTS[57030] = Fluid3D([14947,15404,15218,15303],0); -ELEMENTS[57031] = Fluid3D([15101,14947,15218,14745],0); -ELEMENTS[57032] = Fluid3D([15404,15101,15218,15448],0); -ELEMENTS[57033] = Fluid3D([15404,15101,15448,16083],0); -ELEMENTS[57034] = Fluid3D([15292,15101,15404,15239],0); -ELEMENTS[57035] = Fluid3D([15101,15218,15448,14745],0); -ELEMENTS[57036] = Fluid3D([14947,15292,15404,14607],0); -ELEMENTS[57037] = Fluid3D([15448,15101,14745,14999],0); -ELEMENTS[57038] = Fluid3D([15404,14947,14607,15303],0); -ELEMENTS[57039] = Fluid3D([15101,14947,14745,13952],0); -ELEMENTS[57040] = Fluid3D([15218,15404,15448,15869],0); -ELEMENTS[57041] = Fluid3D([15218,15404,15869,15660],0); -ELEMENTS[57042] = Fluid3D([15404,15448,15869,16083],0); -ELEMENTS[57043] = Fluid3D([15101,15404,15239,16083],0); -ELEMENTS[57044] = Fluid3D([14947,15218,14745,14459],0); -ELEMENTS[57045] = Fluid3D([15404,15869,15660,15641],0); -ELEMENTS[57046] = Fluid3D([15239,14508,15101,14999],0); -ELEMENTS[57047] = Fluid3D([15448,15101,14999,15239],0); -ELEMENTS[57048] = Fluid3D([15448,15101,15239,16083],0); -ELEMENTS[57049] = Fluid3D([17512,17798,17428,17841],0); -ELEMENTS[57050] = Fluid3D([8160,8370,8137,7427],0); -ELEMENTS[57051] = Fluid3D([18218,18124,18325,18379],0); -ELEMENTS[57052] = Fluid3D([18218,18124,18379,18301],0); -ELEMENTS[57053] = Fluid3D([18218,18124,18301,18116],0); -ELEMENTS[57054] = Fluid3D([7355,7371,7523,6627],0); -ELEMENTS[57055] = Fluid3D([7484,7209,8322,7566],0); -ELEMENTS[57056] = Fluid3D([7484,7209,7566,6650],0); -ELEMENTS[57057] = Fluid3D([7209,7566,6650,7011],0); -ELEMENTS[57058] = Fluid3D([7209,7566,7011,7612],0); -ELEMENTS[57059] = Fluid3D([7566,7011,7612,7213],0); -ELEMENTS[57060] = Fluid3D([7011,7612,7213,6534],0); -ELEMENTS[57061] = Fluid3D([7011,7209,7612,7128],0); -ELEMENTS[57062] = Fluid3D([7011,7612,6534,7128],0); -ELEMENTS[57063] = Fluid3D([6650,7209,7011,6534],0); -ELEMENTS[57064] = Fluid3D([7566,6650,7011,7213],0); -ELEMENTS[57065] = Fluid3D([7209,7566,7612,8322],0); -ELEMENTS[57066] = Fluid3D([6119,6694,7085,7027],0); -ELEMENTS[57067] = Fluid3D([11943,12644,11710,12496],0); -ELEMENTS[57068] = Fluid3D([3155,3356,3274,2853],0); -ELEMENTS[57069] = Fluid3D([5378,5249,5131,5709],0); -ELEMENTS[57070] = Fluid3D([14120,13613,13134,12921],0); -ELEMENTS[57071] = Fluid3D([2475,2406,2381,2582],0); -ELEMENTS[57072] = Fluid3D([4952,4326,4359,4639],0); -ELEMENTS[57073] = Fluid3D([12164,11632,12475,13003],0); -ELEMENTS[57074] = Fluid3D([3631,3548,3175,3300],0); -ELEMENTS[57075] = Fluid3D([3631,3548,3300,3623],0); -ELEMENTS[57076] = Fluid3D([12420,12748,13330,13067],0); -ELEMENTS[57077] = Fluid3D([12420,12748,13067,12319],0); -ELEMENTS[57078] = Fluid3D([11834,11105,11448,10552],0); -ELEMENTS[57079] = Fluid3D([18419,18309,18490,18476],0); -ELEMENTS[57080] = Fluid3D([17349,17647,17708,17589],0); -ELEMENTS[57081] = Fluid3D([17708,17349,17589,17335],0); -ELEMENTS[57082] = Fluid3D([15349,14978,14895,14870],0); -ELEMENTS[57083] = Fluid3D([15349,14978,14870,15104],0); -ELEMENTS[57084] = Fluid3D([14895,15349,14870,15179],0); -ELEMENTS[57085] = Fluid3D([15349,14870,15179,15602],0); -ELEMENTS[57086] = Fluid3D([15349,14870,15602,15769],0); -ELEMENTS[57087] = Fluid3D([5690,5448,5328,5112],0); -ELEMENTS[57088] = Fluid3D([3829,3982,3560,3590],0); -ELEMENTS[57089] = Fluid3D([5600,5249,5950,5684],0); -ELEMENTS[57090] = Fluid3D([9414,9262,8962,10110],0); -ELEMENTS[57091] = Fluid3D([14843,14148,14440,14929],0); -ELEMENTS[57092] = Fluid3D([16852,16607,16347,16099],0); -ELEMENTS[57093] = Fluid3D([7910,7545,6934,6917],0); -ELEMENTS[57094] = Fluid3D([13938,14009,13284,13515],0); -ELEMENTS[57095] = Fluid3D([11212,11856,12182,12178],0); -ELEMENTS[57096] = Fluid3D([18557,18447,18506,18457],0); -ELEMENTS[57097] = Fluid3D([18557,18447,18457,18523],0); -ELEMENTS[57098] = Fluid3D([18557,18447,18523,18604],0); -ELEMENTS[57099] = Fluid3D([10577,10980,9949,9598],0); -ELEMENTS[57100] = Fluid3D([9949,10577,9598,9002],0); -ELEMENTS[57101] = Fluid3D([9598,9949,9002,9728],0); -ELEMENTS[57102] = Fluid3D([10577,9598,9002,9438],0); -ELEMENTS[57103] = Fluid3D([13779,13560,12813,13872],0); -ELEMENTS[57104] = Fluid3D([11876,11989,12654,13035],0); -ELEMENTS[57105] = Fluid3D([8619,7755,8432,8595],0); -ELEMENTS[57106] = Fluid3D([11092,11224,11867,10675],0); -ELEMENTS[57107] = Fluid3D([11092,11224,10675,10297],0); -ELEMENTS[57108] = Fluid3D([15737,15110,15715,15704],0); -ELEMENTS[57109] = Fluid3D([8524,8834,8387,7939],0); -ELEMENTS[57110] = Fluid3D([8524,8834,7939,8418],0); -ELEMENTS[57111] = Fluid3D([7939,8524,8418,7551],0); -ELEMENTS[57112] = Fluid3D([8524,8834,8418,8771],0); -ELEMENTS[57113] = Fluid3D([8418,8524,8771,7581],0); -ELEMENTS[57114] = Fluid3D([8387,8524,7939,7514],0); -ELEMENTS[57115] = Fluid3D([15573,15070,15071,15597],0); -ELEMENTS[57116] = Fluid3D([15573,15070,15597,15920],0); -ELEMENTS[57117] = Fluid3D([7991,7505,7651,6812],0); -ELEMENTS[57118] = Fluid3D([13805,14517,14480,14071],0); -ELEMENTS[57119] = Fluid3D([17324,17118,16914,17535],0); -ELEMENTS[57120] = Fluid3D([13975,13161,13691,14103],0); -ELEMENTS[57121] = Fluid3D([2895,3044,3023,2674],0); -ELEMENTS[57122] = Fluid3D([7621,8306,8210,8799],0); -ELEMENTS[57123] = Fluid3D([13626,13511,12633,12961],0); -ELEMENTS[57124] = Fluid3D([11812,12221,12710,12318],0); -ELEMENTS[57125] = Fluid3D([12710,11812,12318,12810],0); -ELEMENTS[57126] = Fluid3D([11812,12221,12318,11449],0); -ELEMENTS[57127] = Fluid3D([12318,11812,11449,10943],0); -ELEMENTS[57128] = Fluid3D([11812,11449,10943,11005],0); -ELEMENTS[57129] = Fluid3D([11449,10943,11005,10927],0); -ELEMENTS[57130] = Fluid3D([11005,11449,10927,12221],0); -ELEMENTS[57131] = Fluid3D([11812,11449,11005,12221],0); -ELEMENTS[57132] = Fluid3D([11449,10943,10927,11827],0); -ELEMENTS[57133] = Fluid3D([11449,10943,11827,12318],0); -ELEMENTS[57134] = Fluid3D([11827,11449,12318,12221],0); -ELEMENTS[57135] = Fluid3D([15034,14692,14607,15292],0); -ELEMENTS[57136] = Fluid3D([15816,15846,16346,16067],0); -ELEMENTS[57137] = Fluid3D([7425,7098,6709,7568],0); -ELEMENTS[57138] = Fluid3D([14008,14785,14395,14627],0); -ELEMENTS[57139] = Fluid3D([17769,17727,18012,17664],0); -ELEMENTS[57140] = Fluid3D([7352,6836,7787,7722],0); -ELEMENTS[57141] = Fluid3D([6123,5539,5881,6244],0); -ELEMENTS[57142] = Fluid3D([4511,4767,5089,5052],0); -ELEMENTS[57143] = Fluid3D([4511,4767,5052,4569],0); -ELEMENTS[57144] = Fluid3D([11721,11181,12327,11162],0); -ELEMENTS[57145] = Fluid3D([13953,13298,13716,14157],0); -ELEMENTS[57146] = Fluid3D([17626,17924,17986,17536],0); -ELEMENTS[57147] = Fluid3D([13846,14205,13204,13496],0); -ELEMENTS[57148] = Fluid3D([17641,17730,17288,17407],0); -ELEMENTS[57149] = Fluid3D([12557,13055,13090,12582],0); -ELEMENTS[57150] = Fluid3D([5429,5916,5516,5191],0); -ELEMENTS[57151] = Fluid3D([13053,12723,13027,13579],0); -ELEMENTS[57152] = Fluid3D([12723,13027,13579,13153],0); -ELEMENTS[57153] = Fluid3D([13579,12723,13153,13198],0); -ELEMENTS[57154] = Fluid3D([13785,13313,12730,13040],0); -ELEMENTS[57155] = Fluid3D([4807,4450,5165,4977],0); -ELEMENTS[57156] = Fluid3D([18114,18172,18213,18388],0); -ELEMENTS[57157] = Fluid3D([14072,13526,13624,14371],0); -ELEMENTS[57158] = Fluid3D([10133,9238,10098,9971],0); -ELEMENTS[57159] = Fluid3D([10133,9238,9971,9378],0); -ELEMENTS[57160] = Fluid3D([12514,13250,13089,13353],0); -ELEMENTS[57161] = Fluid3D([12514,13250,13353,13080],0); -ELEMENTS[57162] = Fluid3D([13250,13353,13080,13753],0); -ELEMENTS[57163] = Fluid3D([13353,13080,13753,12878],0); -ELEMENTS[57164] = Fluid3D([11512,11780,12478,11452],0); -ELEMENTS[57165] = Fluid3D([14804,15186,14454,15016],0); -ELEMENTS[57166] = Fluid3D([8453,8675,9411,9056],0); -ELEMENTS[57167] = Fluid3D([15046,14422,15139,14879],0); -ELEMENTS[57168] = Fluid3D([13328,13897,13981,14394],0); -ELEMENTS[57169] = Fluid3D([11977,12009,11199,11186],0); -ELEMENTS[57170] = Fluid3D([8042,8397,8413,7258],0); -ELEMENTS[57171] = Fluid3D([2151,2378,2137,2453],0); -ELEMENTS[57172] = Fluid3D([3452,3289,3813,3908],0); -ELEMENTS[57173] = Fluid3D([3310,3227,3109,3607],0); -ELEMENTS[57174] = Fluid3D([7898,7132,7509,7706],0); -ELEMENTS[57175] = Fluid3D([1916,1922,1987,2118],0); -ELEMENTS[57176] = Fluid3D([15898,15790,16186,16398],0); -ELEMENTS[57177] = Fluid3D([13102,13659,13968,13790],0); -ELEMENTS[57178] = Fluid3D([8764,9708,9149,9132],0); -ELEMENTS[57179] = Fluid3D([12869,12913,13509,13919],0); -ELEMENTS[57180] = Fluid3D([10050,9855,11058,10391],0); -ELEMENTS[57181] = Fluid3D([2825,2846,3163,2866],0); -ELEMENTS[57182] = Fluid3D([3163,2825,2866,3239],0); -ELEMENTS[57183] = Fluid3D([2825,2846,2866,2627],0); -ELEMENTS[57184] = Fluid3D([12061,12586,11713,11542],0); -ELEMENTS[57185] = Fluid3D([8250,8795,8050,7559],0); -ELEMENTS[57186] = Fluid3D([5936,5770,6043,6715],0); -ELEMENTS[57187] = Fluid3D([8112,7895,8192,7234],0); -ELEMENTS[57188] = Fluid3D([15808,15559,16209,16133],0); -ELEMENTS[57189] = Fluid3D([16209,15808,16133,16277],0); -ELEMENTS[57190] = Fluid3D([15808,15559,16133,15906],0); -ELEMENTS[57191] = Fluid3D([16133,15808,15906,15592],0); -ELEMENTS[57192] = Fluid3D([16133,15808,15592,15915],0); -ELEMENTS[57193] = Fluid3D([16133,15808,15915,16277],0); -ELEMENTS[57194] = Fluid3D([4294,4710,5087,4417],0); -ELEMENTS[57195] = Fluid3D([4294,4710,4417,4122],0); -ELEMENTS[57196] = Fluid3D([4710,4417,4122,4635],0); -ELEMENTS[57197] = Fluid3D([4710,4417,4635,4953],0); -ELEMENTS[57198] = Fluid3D([4122,4710,4635,4357],0); -ELEMENTS[57199] = Fluid3D([18200,18240,18250,18044],0); -ELEMENTS[57200] = Fluid3D([17163,17470,17014,17283],0); -ELEMENTS[57201] = Fluid3D([13311,14026,13172,13410],0); -ELEMENTS[57202] = Fluid3D([15843,15782,16402,15973],0); -ELEMENTS[57203] = Fluid3D([15843,15782,15973,15278],0); -ELEMENTS[57204] = Fluid3D([15973,15843,15278,15643],0); -ELEMENTS[57205] = Fluid3D([15973,15843,15643,16311],0); -ELEMENTS[57206] = Fluid3D([15843,15782,15278,15298],0); -ELEMENTS[57207] = Fluid3D([16402,15843,15973,16375],0); -ELEMENTS[57208] = Fluid3D([15843,15973,16375,16311],0); -ELEMENTS[57209] = Fluid3D([16375,15843,16311,16652],0); -ELEMENTS[57210] = Fluid3D([16311,16375,16652,16892],0); -ELEMENTS[57211] = Fluid3D([15973,16375,16311,16166],0); -ELEMENTS[57212] = Fluid3D([15973,16402,16375,16575],0); -ELEMENTS[57213] = Fluid3D([16375,15973,16575,16166],0); -ELEMENTS[57214] = Fluid3D([16402,16375,16575,16652],0); -ELEMENTS[57215] = Fluid3D([16375,16575,16652,16892],0); -ELEMENTS[57216] = Fluid3D([16402,16375,16652,15843],0); -ELEMENTS[57217] = Fluid3D([16575,16375,16166,16404],0); -ELEMENTS[57218] = Fluid3D([10115,9825,10400,9094],0); -ELEMENTS[57219] = Fluid3D([3594,3789,3526,4120],0); -ELEMENTS[57220] = Fluid3D([6158,5634,5632,5979],0); -ELEMENTS[57221] = Fluid3D([18139,18158,17938,17856],0); -ELEMENTS[57222] = Fluid3D([8688,8537,9456,9903],0); -ELEMENTS[57223] = Fluid3D([2118,2253,1987,2052],0); -ELEMENTS[57224] = Fluid3D([15138,15281,15563,15822],0); -ELEMENTS[57225] = Fluid3D([15563,15138,15822,15526],0); -ELEMENTS[57226] = Fluid3D([13234,12906,13883,13739],0); -ELEMENTS[57227] = Fluid3D([7231,7362,6522,6350],0); -ELEMENTS[57228] = Fluid3D([5016,5458,5240,5686],0); -ELEMENTS[57229] = Fluid3D([9665,9477,9478,8686],0); -ELEMENTS[57230] = Fluid3D([3357,3299,3369,3659],0); -ELEMENTS[57231] = Fluid3D([3357,3299,3659,3542],0); -ELEMENTS[57232] = Fluid3D([17796,17959,17947,18196],0); -ELEMENTS[57233] = Fluid3D([15456,15824,15054,15670],0); -ELEMENTS[57234] = Fluid3D([17420,17793,17509,17367],0); -ELEMENTS[57235] = Fluid3D([16071,16033,16160,16762],0); -ELEMENTS[57236] = Fluid3D([15624,16085,16241,15524],0); -ELEMENTS[57237] = Fluid3D([8923,9382,8418,9331],0); -ELEMENTS[57238] = Fluid3D([8923,9382,9331,9870],0); -ELEMENTS[57239] = Fluid3D([5352,4845,5316,5390],0); -ELEMENTS[57240] = Fluid3D([16514,16573,16767,16983],0); -ELEMENTS[57241] = Fluid3D([16514,16573,16983,17154],0); -ELEMENTS[57242] = Fluid3D([16573,16983,17154,17035],0); -ELEMENTS[57243] = Fluid3D([16983,17154,17035,17271],0); -ELEMENTS[57244] = Fluid3D([16573,16767,16983,17035],0); -ELEMENTS[57245] = Fluid3D([16767,16514,16983,17074],0); -ELEMENTS[57246] = Fluid3D([16514,16983,17074,17051],0); -ELEMENTS[57247] = Fluid3D([16983,17074,17051,17154],0); -ELEMENTS[57248] = Fluid3D([16983,17074,17154,17271],0); -ELEMENTS[57249] = Fluid3D([16983,16767,17074,17271],0); -ELEMENTS[57250] = Fluid3D([17051,16983,17154,16514],0); -ELEMENTS[57251] = Fluid3D([16214,16422,16029,16842],0); -ELEMENTS[57252] = Fluid3D([9747,10214,9583,10652],0); -ELEMENTS[57253] = Fluid3D([17640,17322,17429,17123],0); -ELEMENTS[57254] = Fluid3D([14002,13819,14235,14731],0); -ELEMENTS[57255] = Fluid3D([18042,18216,18018,18202],0); -ELEMENTS[57256] = Fluid3D([13414,12797,13873,13401],0); -ELEMENTS[57257] = Fluid3D([14155,14847,14128,14095],0); -ELEMENTS[57258] = Fluid3D([8395,8880,7934,7818],0); -ELEMENTS[57259] = Fluid3D([12690,11847,11978,11286],0); -ELEMENTS[57260] = Fluid3D([11838,12777,12428,12481],0); -ELEMENTS[57261] = Fluid3D([4778,4817,4231,4384],0); -ELEMENTS[57262] = Fluid3D([17128,17138,16985,16674],0); -ELEMENTS[57263] = Fluid3D([7880,7124,7794,7543],0); -ELEMENTS[57264] = Fluid3D([2474,2414,2245,2481],0); -ELEMENTS[57265] = Fluid3D([2474,2414,2481,2665],0); -ELEMENTS[57266] = Fluid3D([2414,2245,2481,2665],0); -ELEMENTS[57267] = Fluid3D([10896,10215,9709,10776],0); -ELEMENTS[57268] = Fluid3D([9055,8457,9467,8273],0); -ELEMENTS[57269] = Fluid3D([14635,14888,14072,13642],0); -ELEMENTS[57270] = Fluid3D([10527,10071,10268,11278],0); -ELEMENTS[57271] = Fluid3D([10527,10071,11278,11105],0); -ELEMENTS[57272] = Fluid3D([11278,10527,11105,10552],0); -ELEMENTS[57273] = Fluid3D([11278,10527,10552,11286],0); -ELEMENTS[57274] = Fluid3D([11278,10527,11286,11454],0); -ELEMENTS[57275] = Fluid3D([11278,10527,11454,10268],0); -ELEMENTS[57276] = Fluid3D([11286,11278,11454,12405],0); -ELEMENTS[57277] = Fluid3D([10008,10126,9932,11001],0); -ELEMENTS[57278] = Fluid3D([2788,2719,2561,2853],0); -ELEMENTS[57279] = Fluid3D([16799,17071,17295,16932],0); -ELEMENTS[57280] = Fluid3D([17790,17494,17399,17416],0); -ELEMENTS[57281] = Fluid3D([10559,11423,10831,11447],0); -ELEMENTS[57282] = Fluid3D([16098,16103,15553,15545],0); -ELEMENTS[57283] = Fluid3D([16103,15553,15545,16122],0); -ELEMENTS[57284] = Fluid3D([15313,15715,16053,15977],0); -ELEMENTS[57285] = Fluid3D([6513,5794,6365,6211],0); -ELEMENTS[57286] = Fluid3D([6513,5794,6211,6572],0); -ELEMENTS[57287] = Fluid3D([6211,6513,6572,6563],0); -ELEMENTS[57288] = Fluid3D([6572,6211,6563,5945],0); -ELEMENTS[57289] = Fluid3D([6211,6563,5945,6365],0); -ELEMENTS[57290] = Fluid3D([6572,6211,5945,5636],0); -ELEMENTS[57291] = Fluid3D([6211,5945,5636,5794],0); -ELEMENTS[57292] = Fluid3D([6211,5945,5794,6365],0); -ELEMENTS[57293] = Fluid3D([5636,6211,5794,6572],0); -ELEMENTS[57294] = Fluid3D([6365,6513,6211,6563],0); -ELEMENTS[57295] = Fluid3D([14614,14202,13753,13881],0); -ELEMENTS[57296] = Fluid3D([14614,14202,13881,14123],0); -ELEMENTS[57297] = Fluid3D([14202,13881,14123,13505],0); -ELEMENTS[57298] = Fluid3D([13753,14614,13881,13954],0); -ELEMENTS[57299] = Fluid3D([14202,13753,13881,13125],0); -ELEMENTS[57300] = Fluid3D([13753,13881,13125,13954],0); -ELEMENTS[57301] = Fluid3D([3856,3612,3863,4318],0); -ELEMENTS[57302] = Fluid3D([12210,12400,11985,12946],0); -ELEMENTS[57303] = Fluid3D([11985,12210,12946,12498],0); -ELEMENTS[57304] = Fluid3D([14876,15125,15720,15192],0); -ELEMENTS[57305] = Fluid3D([14876,15125,15192,14611],0); -ELEMENTS[57306] = Fluid3D([12785,12824,13721,13518],0); -ELEMENTS[57307] = Fluid3D([13721,12785,13518,13863],0); -ELEMENTS[57308] = Fluid3D([10805,11291,10439,10533],0); -ELEMENTS[57309] = Fluid3D([10805,11291,10533,11826],0); -ELEMENTS[57310] = Fluid3D([11291,10439,10533,10717],0); -ELEMENTS[57311] = Fluid3D([10533,11291,10717,11296],0); -ELEMENTS[57312] = Fluid3D([10533,11291,11296,11826],0); -ELEMENTS[57313] = Fluid3D([10717,10533,11296,10744],0); -ELEMENTS[57314] = Fluid3D([10533,11296,10744,10535],0); -ELEMENTS[57315] = Fluid3D([10717,10533,10744,9803],0); -ELEMENTS[57316] = Fluid3D([11296,10717,10744,11667],0); -ELEMENTS[57317] = Fluid3D([10533,10744,9803,9489],0); -ELEMENTS[57318] = Fluid3D([10744,9803,9489,10299],0); -ELEMENTS[57319] = Fluid3D([10744,9803,10299,10006],0); -ELEMENTS[57320] = Fluid3D([9489,10744,10299,10535],0); -ELEMENTS[57321] = Fluid3D([9803,10533,9489,9612],0); -ELEMENTS[57322] = Fluid3D([10744,10717,9803,10006],0); -ELEMENTS[57323] = Fluid3D([10717,9803,10006,10439],0); -ELEMENTS[57324] = Fluid3D([9803,9489,10299,9404],0); -ELEMENTS[57325] = Fluid3D([9803,9489,9404,8636],0); -ELEMENTS[57326] = Fluid3D([9803,9489,8636,9612],0); -ELEMENTS[57327] = Fluid3D([10717,10533,9803,10439],0); -ELEMENTS[57328] = Fluid3D([9803,10006,10439,9612],0); -ELEMENTS[57329] = Fluid3D([10439,9803,9612,10533],0); -ELEMENTS[57330] = Fluid3D([11291,10717,11296,11667],0); -ELEMENTS[57331] = Fluid3D([10744,10717,10006,10925],0); -ELEMENTS[57332] = Fluid3D([10717,10006,10925,10439],0); -ELEMENTS[57333] = Fluid3D([10744,10717,10925,11667],0); -ELEMENTS[57334] = Fluid3D([10717,10925,11667,11291],0); -ELEMENTS[57335] = Fluid3D([9612,10439,10533,10805],0); -ELEMENTS[57336] = Fluid3D([10533,10744,9489,10535],0); -ELEMENTS[57337] = Fluid3D([10717,10925,11291,10439],0); -ELEMENTS[57338] = Fluid3D([10299,9803,9404,10006],0); -ELEMENTS[57339] = Fluid3D([9803,9404,10006,8636],0); -ELEMENTS[57340] = Fluid3D([9803,10006,9612,8636],0); -ELEMENTS[57341] = Fluid3D([10299,10744,10006,10925],0); -ELEMENTS[57342] = Fluid3D([10299,10744,10925,11667],0); -ELEMENTS[57343] = Fluid3D([3985,3947,3583,3638],0); -ELEMENTS[57344] = Fluid3D([11776,10924,10848,11238],0); -ELEMENTS[57345] = Fluid3D([10924,10848,11238,10205],0); -ELEMENTS[57346] = Fluid3D([7157,7406,7217,6430],0); -ELEMENTS[57347] = Fluid3D([10420,10059,10739,10970],0); -ELEMENTS[57348] = Fluid3D([10351,11196,10199,10796],0); -ELEMENTS[57349] = Fluid3D([17489,17682,17867,17633],0); -ELEMENTS[57350] = Fluid3D([2776,2662,2689,2938],0); -ELEMENTS[57351] = Fluid3D([2243,2186,2094,1939],0); -ELEMENTS[57352] = Fluid3D([13718,14469,14445,14259],0); -ELEMENTS[57353] = Fluid3D([10742,10147,10582,11381],0); -ELEMENTS[57354] = Fluid3D([11847,12690,12405,11286],0); -ELEMENTS[57355] = Fluid3D([8427,8344,9319,9113],0); -ELEMENTS[57356] = Fluid3D([14057,14635,14571,14072],0); -ELEMENTS[57357] = Fluid3D([7454,8223,7778,8439],0); -ELEMENTS[57358] = Fluid3D([12413,12822,12292,11825],0); -ELEMENTS[57359] = Fluid3D([12413,12822,11825,12056],0); -ELEMENTS[57360] = Fluid3D([12822,11825,12056,12292],0); -ELEMENTS[57361] = Fluid3D([12292,12413,11825,11572],0); -ELEMENTS[57362] = Fluid3D([12413,11825,11572,11514],0); -ELEMENTS[57363] = Fluid3D([11825,11572,11514,11363],0); -ELEMENTS[57364] = Fluid3D([12413,11825,11514,12132],0); -ELEMENTS[57365] = Fluid3D([11825,11514,12132,12056],0); -ELEMENTS[57366] = Fluid3D([12132,11825,12056,12413],0); -ELEMENTS[57367] = Fluid3D([11825,11514,12056,11332],0); -ELEMENTS[57368] = Fluid3D([12056,11825,11332,12292],0); -ELEMENTS[57369] = Fluid3D([11825,11514,11332,11363],0); -ELEMENTS[57370] = Fluid3D([11514,12413,12132,11959],0); -ELEMENTS[57371] = Fluid3D([12132,11514,11959,11616],0); -ELEMENTS[57372] = Fluid3D([12132,11514,11616,12056],0); -ELEMENTS[57373] = Fluid3D([11959,12132,11616,12623],0); -ELEMENTS[57374] = Fluid3D([12132,11616,12623,12056],0); -ELEMENTS[57375] = Fluid3D([11959,12132,12623,12413],0); -ELEMENTS[57376] = Fluid3D([12132,12623,12413,12056],0); -ELEMENTS[57377] = Fluid3D([11332,11825,11363,12292],0); -ELEMENTS[57378] = Fluid3D([11572,12413,11514,12032],0); -ELEMENTS[57379] = Fluid3D([11514,12413,11959,12032],0); -ELEMENTS[57380] = Fluid3D([12413,11959,12032,13037],0); -ELEMENTS[57381] = Fluid3D([11959,12032,13037,12286],0); -ELEMENTS[57382] = Fluid3D([11959,12032,12286,11231],0); -ELEMENTS[57383] = Fluid3D([11959,12032,11231,10761],0); -ELEMENTS[57384] = Fluid3D([12286,11959,11231,11616],0); -ELEMENTS[57385] = Fluid3D([11514,11959,11616,11231],0); -ELEMENTS[57386] = Fluid3D([11959,11514,12032,10761],0); -ELEMENTS[57387] = Fluid3D([11825,12292,11572,11739],0); -ELEMENTS[57388] = Fluid3D([12286,11959,11616,12623],0); -ELEMENTS[57389] = Fluid3D([13037,11959,12286,12623],0); -ELEMENTS[57390] = Fluid3D([12623,11959,12413,13037],0); -ELEMENTS[57391] = Fluid3D([12292,11572,11739,12476],0); -ELEMENTS[57392] = Fluid3D([12292,12413,11572,12476],0); -ELEMENTS[57393] = Fluid3D([12413,11572,12476,12032],0); -ELEMENTS[57394] = Fluid3D([14097,13433,14105,13001],0); -ELEMENTS[57395] = Fluid3D([15217,15049,15906,15305],0); -ELEMENTS[57396] = Fluid3D([15217,15049,15305,14657],0); -ELEMENTS[57397] = Fluid3D([14518,14505,15120,14368],0); -ELEMENTS[57398] = Fluid3D([12200,12823,13012,13486],0); -ELEMENTS[57399] = Fluid3D([17747,17443,17830,17587],0); -ELEMENTS[57400] = Fluid3D([4854,4352,4441,4133],0); -ELEMENTS[57401] = Fluid3D([18380,18485,18451,18532],0); -ELEMENTS[57402] = Fluid3D([18380,18485,18532,18453],0); -ELEMENTS[57403] = Fluid3D([18485,18451,18532,18585],0); -ELEMENTS[57404] = Fluid3D([18451,18532,18585,18503],0); -ELEMENTS[57405] = Fluid3D([11664,11147,10978,10570],0); -ELEMENTS[57406] = Fluid3D([10180,10040,9146,9284],0); -ELEMENTS[57407] = Fluid3D([9440,9887,9051,9696],0); -ELEMENTS[57408] = Fluid3D([9140,8471,9506,9377],0); -ELEMENTS[57409] = Fluid3D([10969,10812,11829,11824],0); -ELEMENTS[57410] = Fluid3D([6220,6925,6802,6530],0); -ELEMENTS[57411] = Fluid3D([13828,13098,13835,13952],0); -ELEMENTS[57412] = Fluid3D([16431,16865,16967,16425],0); -ELEMENTS[57413] = Fluid3D([4125,4557,4572,4667],0); -ELEMENTS[57414] = Fluid3D([4125,4557,4667,4479],0); -ELEMENTS[57415] = Fluid3D([4667,4125,4479,4372],0); -ELEMENTS[57416] = Fluid3D([4557,4572,4667,4965],0); -ELEMENTS[57417] = Fluid3D([4572,4667,4965,4350],0); -ELEMENTS[57418] = Fluid3D([4557,4667,4479,4955],0); -ELEMENTS[57419] = Fluid3D([4667,4479,4955,4949],0); -ELEMENTS[57420] = Fluid3D([4955,4667,4949,4965],0); -ELEMENTS[57421] = Fluid3D([4557,4667,4955,4965],0); -ELEMENTS[57422] = Fluid3D([4667,4479,4949,4372],0); -ELEMENTS[57423] = Fluid3D([4479,4955,4949,5139],0); -ELEMENTS[57424] = Fluid3D([4667,4949,4965,4372],0); -ELEMENTS[57425] = Fluid3D([4125,4557,4479,4480],0); -ELEMENTS[57426] = Fluid3D([4479,4557,4955,4480],0); -ELEMENTS[57427] = Fluid3D([4667,4965,4350,4372],0); -ELEMENTS[57428] = Fluid3D([4350,4667,4372,4125],0); -ELEMENTS[57429] = Fluid3D([4572,4667,4350,4125],0); -ELEMENTS[57430] = Fluid3D([14215,14382,13711,14532],0); -ELEMENTS[57431] = Fluid3D([10020,10486,9411,10721],0); -ELEMENTS[57432] = Fluid3D([17485,17699,17702,17872],0); -ELEMENTS[57433] = Fluid3D([17576,17478,17463,17120],0); -ELEMENTS[57434] = Fluid3D([6604,6888,7450,6405],0); -ELEMENTS[57435] = Fluid3D([18207,18296,18244,18062],0); -ELEMENTS[57436] = Fluid3D([18296,18244,18062,18313],0); -ELEMENTS[57437] = Fluid3D([16351,16260,16246,16834],0); -ELEMENTS[57438] = Fluid3D([17905,17921,18043,18203],0); -ELEMENTS[57439] = Fluid3D([18043,17905,18203,18217],0); -ELEMENTS[57440] = Fluid3D([18043,17905,18217,18064],0); -ELEMENTS[57441] = Fluid3D([13006,13131,13405,12973],0); -ELEMENTS[57442] = Fluid3D([13006,13131,12973,12160],0); -ELEMENTS[57443] = Fluid3D([12856,13458,12947,12691],0); -ELEMENTS[57444] = Fluid3D([5028,5354,5081,5651],0); -ELEMENTS[57445] = Fluid3D([7905,7486,8382,7495],0); -ELEMENTS[57446] = Fluid3D([13163,13623,13304,13008],0); -ELEMENTS[57447] = Fluid3D([13163,13623,13008,12643],0); -ELEMENTS[57448] = Fluid3D([13304,13163,13008,12379],0); -ELEMENTS[57449] = Fluid3D([13163,13008,12379,12643],0); -ELEMENTS[57450] = Fluid3D([12379,13163,12643,13146],0); -ELEMENTS[57451] = Fluid3D([7362,6808,6522,6350],0); -ELEMENTS[57452] = Fluid3D([7926,8667,8935,8702],0); -ELEMENTS[57453] = Fluid3D([2957,2751,2511,2777],0); -ELEMENTS[57454] = Fluid3D([2957,2751,2777,3132],0); -ELEMENTS[57455] = Fluid3D([14129,14898,14663,15040],0); -ELEMENTS[57456] = Fluid3D([14898,14663,15040,15620],0); -ELEMENTS[57457] = Fluid3D([9825,10115,9348,9094],0); -ELEMENTS[57458] = Fluid3D([7226,7883,7950,7052],0); -ELEMENTS[57459] = Fluid3D([12670,12248,11786,12262],0); -ELEMENTS[57460] = Fluid3D([11786,12670,12262,12164],0); -ELEMENTS[57461] = Fluid3D([12164,12262,12034,12837],0); -ELEMENTS[57462] = Fluid3D([12262,12034,12837,13407],0); -ELEMENTS[57463] = Fluid3D([5010,5049,5545,5406],0); -ELEMENTS[57464] = Fluid3D([3770,4125,3738,3945],0); -ELEMENTS[57465] = Fluid3D([6526,6689,6718,5719],0); -ELEMENTS[57466] = Fluid3D([10266,9622,9386,10003],0); -ELEMENTS[57467] = Fluid3D([11267,11566,11129,10587],0); -ELEMENTS[57468] = Fluid3D([11267,11566,10587,11524],0); -ELEMENTS[57469] = Fluid3D([16873,16842,17210,17085],0); -ELEMENTS[57470] = Fluid3D([5858,5406,5106,5475],0); -ELEMENTS[57471] = Fluid3D([16419,16271,15706,15964],0); -ELEMENTS[57472] = Fluid3D([15706,16419,15964,15801],0); -ELEMENTS[57473] = Fluid3D([16419,16271,15964,15904],0); -ELEMENTS[57474] = Fluid3D([1977,1976,1873,1829],0); -ELEMENTS[57475] = Fluid3D([12174,11998,11108,11016],0); -ELEMENTS[57476] = Fluid3D([14570,15005,14165,14045],0); -ELEMENTS[57477] = Fluid3D([6060,5963,5979,5494],0); -ELEMENTS[57478] = Fluid3D([5979,6060,5494,6002],0); -ELEMENTS[57479] = Fluid3D([2122,2188,2027,1961],0); -ELEMENTS[57480] = Fluid3D([8506,7914,7493,7731],0); -ELEMENTS[57481] = Fluid3D([13492,13529,13722,14431],0); -ELEMENTS[57482] = Fluid3D([13693,13721,12824,13518],0); -ELEMENTS[57483] = Fluid3D([12357,13307,12610,13283],0); -ELEMENTS[57484] = Fluid3D([14483,14273,13869,13416],0); -ELEMENTS[57485] = Fluid3D([7634,7063,6747,7167],0); -ELEMENTS[57486] = Fluid3D([10169,9431,10766,10455],0); -ELEMENTS[57487] = Fluid3D([10766,10169,10455,10354],0); -ELEMENTS[57488] = Fluid3D([9431,10766,10455,9017],0); -ELEMENTS[57489] = Fluid3D([17545,17269,17719,17451],0); -ELEMENTS[57490] = Fluid3D([6575,5993,5805,5808],0); -ELEMENTS[57491] = Fluid3D([12896,12739,12415,13321],0); -ELEMENTS[57492] = Fluid3D([9682,10377,10680,10705],0); -ELEMENTS[57493] = Fluid3D([14185,13579,14141,13027],0); -ELEMENTS[57494] = Fluid3D([2793,2725,3026,2651],0); -ELEMENTS[57495] = Fluid3D([2725,3026,2651,2595],0); -ELEMENTS[57496] = Fluid3D([2651,2725,2595,2497],0); -ELEMENTS[57497] = Fluid3D([2793,2725,2651,2401],0); -ELEMENTS[57498] = Fluid3D([2725,2651,2401,2497],0); -ELEMENTS[57499] = Fluid3D([3582,3159,3503,3425],0); -ELEMENTS[57500] = Fluid3D([3582,3159,3425,3360],0); -ELEMENTS[57501] = Fluid3D([3503,3582,3425,4000],0); -ELEMENTS[57502] = Fluid3D([3159,3503,3425,3298],0); -ELEMENTS[57503] = Fluid3D([3503,3425,3298,3745],0); -ELEMENTS[57504] = Fluid3D([3425,3298,3745,3403],0); -ELEMENTS[57505] = Fluid3D([3425,3298,3403,2993],0); -ELEMENTS[57506] = Fluid3D([3425,3298,2993,3159],0); -ELEMENTS[57507] = Fluid3D([3503,3425,3745,4000],0); -ELEMENTS[57508] = Fluid3D([3425,3745,4000,3616],0); -ELEMENTS[57509] = Fluid3D([3425,3745,3616,3403],0); -ELEMENTS[57510] = Fluid3D([3616,3425,3403,3049],0); -ELEMENTS[57511] = Fluid3D([3745,4000,3616,3989],0); -ELEMENTS[57512] = Fluid3D([3745,3616,3403,3989],0); -ELEMENTS[57513] = Fluid3D([4000,3425,3616,3582],0); -ELEMENTS[57514] = Fluid3D([3425,3616,3582,3360],0); -ELEMENTS[57515] = Fluid3D([7485,7117,7304,7852],0); -ELEMENTS[57516] = Fluid3D([2500,2544,2588,2287],0); -ELEMENTS[57517] = Fluid3D([10690,9943,10770,10803],0); -ELEMENTS[57518] = Fluid3D([10072,10113,10475,11186],0); -ELEMENTS[57519] = Fluid3D([7352,8117,7357,7747],0); -ELEMENTS[57520] = Fluid3D([10213,10705,9682,10680],0); -ELEMENTS[57521] = Fluid3D([2844,3098,2734,2648],0); -ELEMENTS[57522] = Fluid3D([4755,4997,4830,4384],0); -ELEMENTS[57523] = Fluid3D([4755,4997,4384,4817],0); -ELEMENTS[57524] = Fluid3D([12969,12521,13628,13201],0); -ELEMENTS[57525] = Fluid3D([12334,13261,12641,12113],0); -ELEMENTS[57526] = Fluid3D([2680,2696,2572,2385],0); -ELEMENTS[57527] = Fluid3D([15134,15806,15492,15436],0); -ELEMENTS[57528] = Fluid3D([18270,18354,18092,18112],0); -ELEMENTS[57529] = Fluid3D([12686,12068,12383,12678],0); -ELEMENTS[57530] = Fluid3D([5654,5934,5845,6462],0); -ELEMENTS[57531] = Fluid3D([5663,6224,5611,5825],0); -ELEMENTS[57532] = Fluid3D([5663,6224,5825,6233],0); -ELEMENTS[57533] = Fluid3D([6224,5825,6233,6083],0); -ELEMENTS[57534] = Fluid3D([5825,6233,6083,5747],0); -ELEMENTS[57535] = Fluid3D([6224,5825,6083,5611],0); -ELEMENTS[57536] = Fluid3D([6083,5825,5747,5234],0); -ELEMENTS[57537] = Fluid3D([5825,6083,5611,5234],0); -ELEMENTS[57538] = Fluid3D([5611,5825,5234,5663],0); -ELEMENTS[57539] = Fluid3D([5825,5663,6233,5541],0); -ELEMENTS[57540] = Fluid3D([6233,5825,5541,5747],0); -ELEMENTS[57541] = Fluid3D([9173,8551,8203,8525],0); -ELEMENTS[57542] = Fluid3D([8203,9173,8525,8921],0); -ELEMENTS[57543] = Fluid3D([9173,8551,8525,9002],0); -ELEMENTS[57544] = Fluid3D([8525,9173,9002,9728],0); -ELEMENTS[57545] = Fluid3D([5998,6318,5457,5758],0); -ELEMENTS[57546] = Fluid3D([15331,15901,15639,15543],0); -ELEMENTS[57547] = Fluid3D([12249,12466,11868,11310],0); -ELEMENTS[57548] = Fluid3D([2537,2563,2271,2334],0); -ELEMENTS[57549] = Fluid3D([3536,3513,3286,3682],0); -ELEMENTS[57550] = Fluid3D([15921,15112,15003,15245],0); -ELEMENTS[57551] = Fluid3D([16719,16206,16686,16717],0); -ELEMENTS[57552] = Fluid3D([14546,15221,15043,15625],0); -ELEMENTS[57553] = Fluid3D([6028,5432,5656,5299],0); -ELEMENTS[57554] = Fluid3D([5656,6028,5299,6146],0); -ELEMENTS[57555] = Fluid3D([5656,6028,6146,6583],0); -ELEMENTS[57556] = Fluid3D([5677,5983,5657,5287],0); -ELEMENTS[57557] = Fluid3D([5677,5983,5287,5905],0); -ELEMENTS[57558] = Fluid3D([5287,5677,5905,5538],0); -ELEMENTS[57559] = Fluid3D([8877,8347,9108,7740],0); -ELEMENTS[57560] = Fluid3D([4319,4475,4723,4237],0); -ELEMENTS[57561] = Fluid3D([4701,4608,5151,4558],0); -ELEMENTS[57562] = Fluid3D([11134,11747,10524,10681],0); -ELEMENTS[57563] = Fluid3D([11134,11747,10681,11613],0); -ELEMENTS[57564] = Fluid3D([14740,15383,14627,15529],0); -ELEMENTS[57565] = Fluid3D([14262,14926,14717,14338],0); -ELEMENTS[57566] = Fluid3D([13734,13215,12706,12884],0); -ELEMENTS[57567] = Fluid3D([12074,12936,11890,12165],0); -ELEMENTS[57568] = Fluid3D([13093,12721,13668,13190],0); -ELEMENTS[57569] = Fluid3D([17886,17609,18033,17817],0); -ELEMENTS[57570] = Fluid3D([17886,17609,17817,17639],0); -ELEMENTS[57571] = Fluid3D([8672,8222,7622,7826],0); -ELEMENTS[57572] = Fluid3D([8222,7622,7826,7492],0); -ELEMENTS[57573] = Fluid3D([7622,7826,7492,6900],0); -ELEMENTS[57574] = Fluid3D([15836,15768,15175,15936],0); -ELEMENTS[57575] = Fluid3D([10604,9866,9858,9313],0); -ELEMENTS[57576] = Fluid3D([5793,5679,5218,5194],0); -ELEMENTS[57577] = Fluid3D([12723,12388,13153,13198],0); -ELEMENTS[57578] = Fluid3D([14333,14282,13781,13329],0); -ELEMENTS[57579] = Fluid3D([13781,14333,13329,14571],0); -ELEMENTS[57580] = Fluid3D([13781,14333,14571,14853],0); -ELEMENTS[57581] = Fluid3D([14333,14571,14853,15406],0); -ELEMENTS[57582] = Fluid3D([2263,2384,2109,2385],0); -ELEMENTS[57583] = Fluid3D([11660,11553,12171,11001],0); -ELEMENTS[57584] = Fluid3D([9849,9132,8908,10057],0); -ELEMENTS[57585] = Fluid3D([11968,11268,10914,11883],0); -ELEMENTS[57586] = Fluid3D([11968,11268,11883,12243],0); -ELEMENTS[57587] = Fluid3D([11894,12652,11952,11583],0); -ELEMENTS[57588] = Fluid3D([11654,11079,11923,11498],0); -ELEMENTS[57589] = Fluid3D([5524,5696,5295,5223],0); -ELEMENTS[57590] = Fluid3D([8963,9205,8861,9833],0); -ELEMENTS[57591] = Fluid3D([8963,9205,9833,9819],0); -ELEMENTS[57592] = Fluid3D([4890,5278,4850,4730],0); -ELEMENTS[57593] = Fluid3D([16159,16313,16624,16868],0); -ELEMENTS[57594] = Fluid3D([15873,16017,15502,16257],0); -ELEMENTS[57595] = Fluid3D([15873,16017,16257,16480],0); -ELEMENTS[57596] = Fluid3D([13203,13003,13463,12684],0); -ELEMENTS[57597] = Fluid3D([12537,13175,13604,13247],0); -ELEMENTS[57598] = Fluid3D([13604,12537,13247,13149],0); -ELEMENTS[57599] = Fluid3D([13247,13604,13149,13336],0); -ELEMENTS[57600] = Fluid3D([13247,13604,13336,13553],0); -ELEMENTS[57601] = Fluid3D([13247,13604,13553,13175],0); -ELEMENTS[57602] = Fluid3D([17768,17613,17437,17291],0); -ELEMENTS[57603] = Fluid3D([14621,14182,14298,14572],0); -ELEMENTS[57604] = Fluid3D([14182,14298,14572,13471],0); -ELEMENTS[57605] = Fluid3D([15795,15758,16304,16411],0); -ELEMENTS[57606] = Fluid3D([5643,5438,5238,4979],0); -ELEMENTS[57607] = Fluid3D([5238,5643,4979,5175],0); -ELEMENTS[57608] = Fluid3D([5643,5438,4979,5123],0); -ELEMENTS[57609] = Fluid3D([5438,4979,5123,4875],0); -ELEMENTS[57610] = Fluid3D([4979,5643,5123,5384],0); -ELEMENTS[57611] = Fluid3D([5643,5438,5123,5549],0); -ELEMENTS[57612] = Fluid3D([5438,5123,5549,5665],0); -ELEMENTS[57613] = Fluid3D([5438,5123,5665,4851],0); -ELEMENTS[57614] = Fluid3D([5438,5238,4979,4875],0); -ELEMENTS[57615] = Fluid3D([5643,4979,5175,4896],0); -ELEMENTS[57616] = Fluid3D([4979,5238,5175,4537],0); -ELEMENTS[57617] = Fluid3D([3096,2852,3103,3138],0); -ELEMENTS[57618] = Fluid3D([17634,17751,17393,17700],0); -ELEMENTS[57619] = Fluid3D([4237,3771,3680,3905],0); -ELEMENTS[57620] = Fluid3D([3771,3680,3905,3334],0); -ELEMENTS[57621] = Fluid3D([17947,17643,17896,17645],0); -ELEMENTS[57622] = Fluid3D([11398,12306,12323,11816],0); -ELEMENTS[57623] = Fluid3D([11398,12306,11816,11704],0); -ELEMENTS[57624] = Fluid3D([7860,8694,8850,9095],0); -ELEMENTS[57625] = Fluid3D([13287,13586,12803,13705],0); -ELEMENTS[57626] = Fluid3D([8176,7664,7133,7273],0); -ELEMENTS[57627] = Fluid3D([4010,3902,3880,4384],0); -ELEMENTS[57628] = Fluid3D([4010,3902,4384,4352],0); -ELEMENTS[57629] = Fluid3D([3880,4010,4384,4231],0); -ELEMENTS[57630] = Fluid3D([2740,3057,2924,2677],0); -ELEMENTS[57631] = Fluid3D([5062,5431,4762,5342],0); -ELEMENTS[57632] = Fluid3D([5062,5431,5342,5660],0); -ELEMENTS[57633] = Fluid3D([5062,5431,5660,5844],0); -ELEMENTS[57634] = Fluid3D([10424,10883,11236,11768],0); -ELEMENTS[57635] = Fluid3D([11969,12506,11537,11835],0); -ELEMENTS[57636] = Fluid3D([16892,16741,16311,16404],0); -ELEMENTS[57637] = Fluid3D([14537,15297,14545,14754],0); -ELEMENTS[57638] = Fluid3D([14537,15297,14754,15393],0); -ELEMENTS[57639] = Fluid3D([14545,14537,14754,14108],0); -ELEMENTS[57640] = Fluid3D([9734,10483,9932,9241],0); -ELEMENTS[57641] = Fluid3D([5040,4460,4783,4912],0); -ELEMENTS[57642] = Fluid3D([17527,17286,17229,17621],0); -ELEMENTS[57643] = Fluid3D([6014,6490,6630,7113],0); -ELEMENTS[57644] = Fluid3D([3363,3433,3002,3219],0); -ELEMENTS[57645] = Fluid3D([7607,7943,8432,8426],0); -ELEMENTS[57646] = Fluid3D([3951,4176,3604,4103],0); -ELEMENTS[57647] = Fluid3D([15611,15718,16266,15508],0); -ELEMENTS[57648] = Fluid3D([15611,15718,15508,14801],0); -ELEMENTS[57649] = Fluid3D([6918,7359,6711,7653],0); -ELEMENTS[57650] = Fluid3D([7284,7937,8505,8323],0); -ELEMENTS[57651] = Fluid3D([3811,3713,3993,4215],0); -ELEMENTS[57652] = Fluid3D([4587,4794,4425,5195],0); -ELEMENTS[57653] = Fluid3D([16238,15984,16674,16252],0); -ELEMENTS[57654] = Fluid3D([11234,10591,10351,10541],0); -ELEMENTS[57655] = Fluid3D([10351,11234,10541,11866],0); -ELEMENTS[57656] = Fluid3D([10807,10596,10109,11447],0); -ELEMENTS[57657] = Fluid3D([6618,7457,7181,7665],0); -ELEMENTS[57658] = Fluid3D([15625,16178,16202,15840],0); -ELEMENTS[57659] = Fluid3D([12319,12193,12031,11041],0); -ELEMENTS[57660] = Fluid3D([7920,8141,8906,8390],0); -ELEMENTS[57661] = Fluid3D([16743,16704,16565,16288],0); -ELEMENTS[57662] = Fluid3D([9797,9615,9591,10413],0); -ELEMENTS[57663] = Fluid3D([9591,9797,10413,11077],0); -ELEMENTS[57664] = Fluid3D([9797,9615,10413,10672],0); -ELEMENTS[57665] = Fluid3D([10413,9797,10672,11077],0); -ELEMENTS[57666] = Fluid3D([4267,4361,4662,4232],0); -ELEMENTS[57667] = Fluid3D([12844,13368,13249,12751],0); -ELEMENTS[57668] = Fluid3D([8345,7580,8375,8121],0); -ELEMENTS[57669] = Fluid3D([6521,6682,5863,6644],0); -ELEMENTS[57670] = Fluid3D([4567,4976,4506,4286],0); -ELEMENTS[57671] = Fluid3D([6237,6354,5715,5578],0); -ELEMENTS[57672] = Fluid3D([7306,7425,7149,8046],0); -ELEMENTS[57673] = Fluid3D([7043,6751,7692,6457],0); -ELEMENTS[57674] = Fluid3D([8580,9442,8693,9063],0); -ELEMENTS[57675] = Fluid3D([17705,17769,17596,17293],0); -ELEMENTS[57676] = Fluid3D([6524,6779,7608,6860],0); -ELEMENTS[57677] = Fluid3D([11881,12647,11523,12296],0); -ELEMENTS[57678] = Fluid3D([11881,12647,12296,12459],0); -ELEMENTS[57679] = Fluid3D([12296,11881,12459,11210],0); -ELEMENTS[57680] = Fluid3D([11523,11881,12296,11210],0); -ELEMENTS[57681] = Fluid3D([12647,11523,12296,12378],0); -ELEMENTS[57682] = Fluid3D([12459,12296,11210,11359],0); -ELEMENTS[57683] = Fluid3D([12296,11210,11359,11303],0); -ELEMENTS[57684] = Fluid3D([11210,11359,11303,10542],0); -ELEMENTS[57685] = Fluid3D([11303,11210,10542,11523],0); -ELEMENTS[57686] = Fluid3D([10542,11303,11523,11327],0); -ELEMENTS[57687] = Fluid3D([10542,11303,11327,10410],0); -ELEMENTS[57688] = Fluid3D([11303,11327,10410,11359],0); -ELEMENTS[57689] = Fluid3D([11303,11523,11327,12105],0); -ELEMENTS[57690] = Fluid3D([11327,11303,12105,11359],0); -ELEMENTS[57691] = Fluid3D([11303,11523,12105,12296],0); -ELEMENTS[57692] = Fluid3D([12105,11303,12296,11359],0); -ELEMENTS[57693] = Fluid3D([11523,12105,12296,12378],0); -ELEMENTS[57694] = Fluid3D([11303,11210,11523,12296],0); -ELEMENTS[57695] = Fluid3D([11210,11359,10542,10207],0); -ELEMENTS[57696] = Fluid3D([11210,12459,11359,11934],0); -ELEMENTS[57697] = Fluid3D([11359,11210,11934,11103],0); -ELEMENTS[57698] = Fluid3D([11359,11210,11103,10207],0); -ELEMENTS[57699] = Fluid3D([12459,12296,11359,12105],0); -ELEMENTS[57700] = Fluid3D([12459,12296,12105,13045],0); -ELEMENTS[57701] = Fluid3D([12296,12105,13045,12378],0); -ELEMENTS[57702] = Fluid3D([12459,12296,13045,13141],0); -ELEMENTS[57703] = Fluid3D([12296,13045,13141,12378],0); -ELEMENTS[57704] = Fluid3D([12459,12296,13141,12647],0); -ELEMENTS[57705] = Fluid3D([12296,13141,12647,12378],0); -ELEMENTS[57706] = Fluid3D([2688,2928,2687,3148],0); -ELEMENTS[57707] = Fluid3D([12147,12927,12884,13225],0); -ELEMENTS[57708] = Fluid3D([17315,17374,17006,17451],0); -ELEMENTS[57709] = Fluid3D([14539,14528,13760,13955],0); -ELEMENTS[57710] = Fluid3D([5256,5878,5885,5542],0); -ELEMENTS[57711] = Fluid3D([2538,2261,2465,2606],0); -ELEMENTS[57712] = Fluid3D([15057,15375,15551,15114],0); -ELEMENTS[57713] = Fluid3D([12313,12694,13576,13058],0); -ELEMENTS[57714] = Fluid3D([17887,17720,17722,18063],0); -ELEMENTS[57715] = Fluid3D([17808,17700,17634,17383],0); -ELEMENTS[57716] = Fluid3D([8859,8789,8672,8029],0); -ELEMENTS[57717] = Fluid3D([10477,10943,11005,11812],0); -ELEMENTS[57718] = Fluid3D([6004,5560,5518,5144],0); -ELEMENTS[57719] = Fluid3D([16839,16935,16957,17473],0); -ELEMENTS[57720] = Fluid3D([6767,6517,6841,6363],0); -ELEMENTS[57721] = Fluid3D([6841,6767,6363,6839],0); -ELEMENTS[57722] = Fluid3D([6517,6841,6363,6374],0); -ELEMENTS[57723] = Fluid3D([6767,6517,6363,6027],0); -ELEMENTS[57724] = Fluid3D([18572,18606,18645,18661],0); -ELEMENTS[57725] = Fluid3D([18398,18268,18421,18458],0); -ELEMENTS[57726] = Fluid3D([18398,18268,18458,18324],0); -ELEMENTS[57727] = Fluid3D([18458,18398,18324,18222],0); -ELEMENTS[57728] = Fluid3D([14115,14296,14072,14793],0); -ELEMENTS[57729] = Fluid3D([4568,4996,4753,5063],0); -ELEMENTS[57730] = Fluid3D([4568,4996,5063,4583],0); -ELEMENTS[57731] = Fluid3D([11623,10957,10959,10384],0); -ELEMENTS[57732] = Fluid3D([13205,12478,13364,13589],0); -ELEMENTS[57733] = Fluid3D([16798,17040,16574,16693],0); -ELEMENTS[57734] = Fluid3D([12037,12848,12462,13190],0); -ELEMENTS[57735] = Fluid3D([16046,16082,16423,16567],0); -ELEMENTS[57736] = Fluid3D([11495,11325,11316,10430],0); -ELEMENTS[57737] = Fluid3D([11495,11325,10430,10988],0); -ELEMENTS[57738] = Fluid3D([8658,8378,7691,8331],0); -ELEMENTS[57739] = Fluid3D([7691,8658,8331,7716],0); -ELEMENTS[57740] = Fluid3D([8331,7691,7716,6902],0); -ELEMENTS[57741] = Fluid3D([13017,13630,13174,12808],0); -ELEMENTS[57742] = Fluid3D([16022,16349,15974,16565],0); -ELEMENTS[57743] = Fluid3D([8417,8804,7968,8398],0); -ELEMENTS[57744] = Fluid3D([12959,12503,13756,13665],0); -ELEMENTS[57745] = Fluid3D([16309,16500,15927,16736],0); -ELEMENTS[57746] = Fluid3D([11962,12271,12222,11260],0); -ELEMENTS[57747] = Fluid3D([16070,15524,15588,15347],0); -ELEMENTS[57748] = Fluid3D([4849,4884,4411,4835],0); -ELEMENTS[57749] = Fluid3D([14526,14841,14589,15207],0); -ELEMENTS[57750] = Fluid3D([14589,14526,15207,15266],0); -ELEMENTS[57751] = Fluid3D([9882,9708,10359,10697],0); -ELEMENTS[57752] = Fluid3D([9882,9708,10697,10818],0); -ELEMENTS[57753] = Fluid3D([10697,9882,10818,11397],0); -ELEMENTS[57754] = Fluid3D([10818,10697,11397,11208],0); -ELEMENTS[57755] = Fluid3D([10818,10697,11208,10325],0); -ELEMENTS[57756] = Fluid3D([10697,11208,10325,10359],0); -ELEMENTS[57757] = Fluid3D([10697,11397,11208,10359],0); -ELEMENTS[57758] = Fluid3D([10818,10697,10325,9708],0); -ELEMENTS[57759] = Fluid3D([10697,10325,9708,10359],0); -ELEMENTS[57760] = Fluid3D([10359,9882,10697,11397],0); -ELEMENTS[57761] = Fluid3D([10931,11648,11704,11398],0); -ELEMENTS[57762] = Fluid3D([9761,10831,10720,10666],0); -ELEMENTS[57763] = Fluid3D([5399,5276,4767,5089],0); -ELEMENTS[57764] = Fluid3D([10699,9961,10874,11424],0); -ELEMENTS[57765] = Fluid3D([16422,16214,16691,16842],0); -ELEMENTS[57766] = Fluid3D([6739,7407,7170,6528],0); -ELEMENTS[57767] = Fluid3D([3116,3032,2800,2653],0); -ELEMENTS[57768] = Fluid3D([17333,16967,16865,16897],0); -ELEMENTS[57769] = Fluid3D([13839,14252,13814,14632],0); -ELEMENTS[57770] = Fluid3D([3431,3462,3772,3916],0); -ELEMENTS[57771] = Fluid3D([5992,6200,6204,5442],0); -ELEMENTS[57772] = Fluid3D([11259,11172,11406,12280],0); -ELEMENTS[57773] = Fluid3D([10529,10701,10104,11089],0); -ELEMENTS[57774] = Fluid3D([10701,10104,11089,10493],0); -ELEMENTS[57775] = Fluid3D([10701,10104,10493,10290],0); -ELEMENTS[57776] = Fluid3D([6397,5952,6005,5535],0); -ELEMENTS[57777] = Fluid3D([17993,17806,18099,18036],0); -ELEMENTS[57778] = Fluid3D([14492,14510,14956,15219],0); -ELEMENTS[57779] = Fluid3D([4406,4411,4365,3962],0); -ELEMENTS[57780] = Fluid3D([4406,4411,3962,4023],0); -ELEMENTS[57781] = Fluid3D([4406,4411,4023,4469],0); -ELEMENTS[57782] = Fluid3D([3962,4406,4023,4205],0); -ELEMENTS[57783] = Fluid3D([14310,13700,13976,13997],0); -ELEMENTS[57784] = Fluid3D([5928,5531,6229,5848],0); -ELEMENTS[57785] = Fluid3D([12198,11641,11901,12871],0); -ELEMENTS[57786] = Fluid3D([9723,10615,9620,10855],0); -ELEMENTS[57787] = Fluid3D([9400,8399,9286,8910],0); -ELEMENTS[57788] = Fluid3D([8399,9286,8910,8228],0); -ELEMENTS[57789] = Fluid3D([6496,6329,6812,7308],0); -ELEMENTS[57790] = Fluid3D([8605,9365,8597,8204],0); -ELEMENTS[57791] = Fluid3D([12444,12015,12704,13525],0); -ELEMENTS[57792] = Fluid3D([13502,14124,13918,13138],0); -ELEMENTS[57793] = Fluid3D([9754,9216,8771,9455],0); -ELEMENTS[57794] = Fluid3D([13484,13027,12442,13153],0); -ELEMENTS[57795] = Fluid3D([16251,16214,16029,16418],0); -ELEMENTS[57796] = Fluid3D([16029,16251,16418,15914],0); -ELEMENTS[57797] = Fluid3D([16251,16214,16418,16873],0); -ELEMENTS[57798] = Fluid3D([16214,16029,16418,16842],0); -ELEMENTS[57799] = Fluid3D([4743,4881,4264,4684],0); -ELEMENTS[57800] = Fluid3D([8950,9357,9353,8282],0); -ELEMENTS[57801] = Fluid3D([8841,7928,8233,7967],0); -ELEMENTS[57802] = Fluid3D([3575,3618,3952,3410],0); -ELEMENTS[57803] = Fluid3D([16514,16102,16619,16069],0); -ELEMENTS[57804] = Fluid3D([14347,14165,13520,13856],0); -ELEMENTS[57805] = Fluid3D([14347,14165,13856,14684],0); -ELEMENTS[57806] = Fluid3D([14165,13520,13856,12970],0); -ELEMENTS[57807] = Fluid3D([14165,13856,14684,14570],0); -ELEMENTS[57808] = Fluid3D([13856,14684,14570,14227],0); -ELEMENTS[57809] = Fluid3D([14684,14570,14227,14991],0); -ELEMENTS[57810] = Fluid3D([14570,14227,14991,14767],0); -ELEMENTS[57811] = Fluid3D([14684,14570,14991,15309],0); -ELEMENTS[57812] = Fluid3D([14570,14991,15309,14767],0); -ELEMENTS[57813] = Fluid3D([14570,13856,14227,14045],0); -ELEMENTS[57814] = Fluid3D([13856,14165,12970,14045],0); -ELEMENTS[57815] = Fluid3D([13856,14165,14045,14570],0); -ELEMENTS[57816] = Fluid3D([16748,17071,16799,16932],0); -ELEMENTS[57817] = Fluid3D([1816,1804,1875,1975],0); -ELEMENTS[57818] = Fluid3D([1875,1816,1975,2056],0); -ELEMENTS[57819] = Fluid3D([1804,1875,1975,1913],0); -ELEMENTS[57820] = Fluid3D([1875,1975,1913,2087],0); -ELEMENTS[57821] = Fluid3D([1975,1913,2087,2086],0); -ELEMENTS[57822] = Fluid3D([1975,1804,1913,2086],0); -ELEMENTS[57823] = Fluid3D([1913,2087,2086,2080],0); -ELEMENTS[57824] = Fluid3D([13811,13583,13119,13806],0); -ELEMENTS[57825] = Fluid3D([11390,11835,11647,10548],0); -ELEMENTS[57826] = Fluid3D([11187,11783,10606,10434],0); -ELEMENTS[57827] = Fluid3D([5258,4693,5229,4793],0); -ELEMENTS[57828] = Fluid3D([6650,6369,7209,6534],0); -ELEMENTS[57829] = Fluid3D([7698,7572,7615,6868],0); -ELEMENTS[57830] = Fluid3D([7615,7698,6868,6736],0); -ELEMENTS[57831] = Fluid3D([16331,16524,16003,16174],0); -ELEMENTS[57832] = Fluid3D([3137,2846,2859,3156],0); -ELEMENTS[57833] = Fluid3D([3137,2846,3156,3009],0); -ELEMENTS[57834] = Fluid3D([3156,3137,3009,3511],0); -ELEMENTS[57835] = Fluid3D([7513,6891,7604,7117],0); -ELEMENTS[57836] = Fluid3D([11969,11506,11540,10557],0); -ELEMENTS[57837] = Fluid3D([17464,17035,17154,17271],0); -ELEMENTS[57838] = Fluid3D([5008,5390,5857,5316],0); -ELEMENTS[57839] = Fluid3D([8813,8610,8295,7981],0); -ELEMENTS[57840] = Fluid3D([8295,8813,7981,8874],0); -ELEMENTS[57841] = Fluid3D([13304,14136,13265,13623],0); -ELEMENTS[57842] = Fluid3D([3339,3698,3308,3504],0); -ELEMENTS[57843] = Fluid3D([7054,6873,6164,6748],0); -ELEMENTS[57844] = Fluid3D([7054,6873,6748,7299],0); -ELEMENTS[57845] = Fluid3D([8429,9420,9191,8961],0); -ELEMENTS[57846] = Fluid3D([3985,4368,4088,3879],0); -ELEMENTS[57847] = Fluid3D([4743,5269,4691,4791],0); -ELEMENTS[57848] = Fluid3D([6875,6614,6067,7015],0); -ELEMENTS[57849] = Fluid3D([8734,8182,8209,7734],0); -ELEMENTS[57850] = Fluid3D([8734,8182,7734,7811],0); -ELEMENTS[57851] = Fluid3D([8182,7734,7811,7000],0); -ELEMENTS[57852] = Fluid3D([7734,7811,7000,7529],0); -ELEMENTS[57853] = Fluid3D([7734,7811,7529,8385],0); -ELEMENTS[57854] = Fluid3D([7000,7734,7529,6714],0); -ELEMENTS[57855] = Fluid3D([8182,8209,7734,7403],0); -ELEMENTS[57856] = Fluid3D([7734,8182,7403,7000],0); -ELEMENTS[57857] = Fluid3D([7186,7268,6961,6311],0); -ELEMENTS[57858] = Fluid3D([16366,15907,15911,16443],0); -ELEMENTS[57859] = Fluid3D([16366,15907,16443,16063],0); -ELEMENTS[57860] = Fluid3D([15911,16366,16443,16464],0); -ELEMENTS[57861] = Fluid3D([9495,9103,9085,9800],0); -ELEMENTS[57862] = Fluid3D([15669,15126,15557,15897],0); -ELEMENTS[57863] = Fluid3D([15669,15126,15897,15277],0); -ELEMENTS[57864] = Fluid3D([11537,12528,12369,11701],0); -ELEMENTS[57865] = Fluid3D([13256,13471,12690,13663],0); -ELEMENTS[57866] = Fluid3D([13256,13471,13663,14101],0); -ELEMENTS[57867] = Fluid3D([13256,13471,14101,14437],0); -ELEMENTS[57868] = Fluid3D([13663,13256,14101,14087],0); -ELEMENTS[57869] = Fluid3D([13256,14101,14087,14437],0); -ELEMENTS[57870] = Fluid3D([14101,14087,14437,14561],0); -ELEMENTS[57871] = Fluid3D([14101,14087,14561,14011],0); -ELEMENTS[57872] = Fluid3D([14101,13663,14087,14011],0); -ELEMENTS[57873] = Fluid3D([13663,14087,14011,13256],0); -ELEMENTS[57874] = Fluid3D([14101,13663,14011,14561],0); -ELEMENTS[57875] = Fluid3D([13663,14011,14561,13669],0); -ELEMENTS[57876] = Fluid3D([14101,13663,14561,13471],0); -ELEMENTS[57877] = Fluid3D([13663,14011,13669,13248],0); -ELEMENTS[57878] = Fluid3D([13663,14011,13248,13256],0); -ELEMENTS[57879] = Fluid3D([14437,14101,14561,14572],0); -ELEMENTS[57880] = Fluid3D([14101,14561,14572,13471],0); -ELEMENTS[57881] = Fluid3D([14087,14561,14011,15015],0); -ELEMENTS[57882] = Fluid3D([14437,14101,14572,14348],0); -ELEMENTS[57883] = Fluid3D([12690,13256,13663,13248],0); -ELEMENTS[57884] = Fluid3D([13663,12690,13248,13669],0); -ELEMENTS[57885] = Fluid3D([14101,14572,14348,13471],0); -ELEMENTS[57886] = Fluid3D([14437,14101,14348,13471],0); -ELEMENTS[57887] = Fluid3D([13471,12690,13663,13669],0); -ELEMENTS[57888] = Fluid3D([13663,13471,13669,14561],0); -ELEMENTS[57889] = Fluid3D([16315,16565,16704,15878],0); -ELEMENTS[57890] = Fluid3D([16519,16610,16625,17196],0); -ELEMENTS[57891] = Fluid3D([16989,17209,17508,17371],0); -ELEMENTS[57892] = Fluid3D([16989,17209,17371,17062],0); -ELEMENTS[57893] = Fluid3D([13369,12923,12646,12377],0); -ELEMENTS[57894] = Fluid3D([6272,6237,6959,6133],0); -ELEMENTS[57895] = Fluid3D([6272,6237,6133,5578],0); -ELEMENTS[57896] = Fluid3D([6237,6959,6133,6803],0); -ELEMENTS[57897] = Fluid3D([14205,13846,13747,13496],0); -ELEMENTS[57898] = Fluid3D([7515,8304,7166,7791],0); -ELEMENTS[57899] = Fluid3D([16719,16792,16697,17293],0); -ELEMENTS[57900] = Fluid3D([16479,16206,15774,16259],0); -ELEMENTS[57901] = Fluid3D([18283,18446,18298,18177],0); -ELEMENTS[57902] = Fluid3D([12759,12987,13566,12382],0); -ELEMENTS[57903] = Fluid3D([12759,12987,12382,11791],0); -ELEMENTS[57904] = Fluid3D([3622,3512,3462,4034],0); -ELEMENTS[57905] = Fluid3D([7716,7210,7628,6874],0); -ELEMENTS[57906] = Fluid3D([7716,7210,6874,6902],0); -ELEMENTS[57907] = Fluid3D([7210,7628,6874,6892],0); -ELEMENTS[57908] = Fluid3D([6874,7210,6892,6789],0); -ELEMENTS[57909] = Fluid3D([6874,7210,6789,6224],0); -ELEMENTS[57910] = Fluid3D([6874,7210,6224,6902],0); -ELEMENTS[57911] = Fluid3D([7395,7219,7126,6450],0); -ELEMENTS[57912] = Fluid3D([7395,7219,6450,6646],0); -ELEMENTS[57913] = Fluid3D([7219,7126,6450,6708],0); -ELEMENTS[57914] = Fluid3D([6450,7219,6708,7150],0); -ELEMENTS[57915] = Fluid3D([6450,7219,7150,6996],0); -ELEMENTS[57916] = Fluid3D([7219,6708,7150,7357],0); -ELEMENTS[57917] = Fluid3D([7219,6708,7357,7126],0); -ELEMENTS[57918] = Fluid3D([6708,7357,7126,6608],0); -ELEMENTS[57919] = Fluid3D([6746,6533,7410,7158],0); -ELEMENTS[57920] = Fluid3D([15539,15682,15490,14956],0); -ELEMENTS[57921] = Fluid3D([15682,15490,14956,15223],0); -ELEMENTS[57922] = Fluid3D([13075,13522,13872,13024],0); -ELEMENTS[57923] = Fluid3D([11718,12493,11989,11896],0); -ELEMENTS[57924] = Fluid3D([5997,5431,5342,5664],0); -ELEMENTS[57925] = Fluid3D([5431,5342,5664,4762],0); -ELEMENTS[57926] = Fluid3D([14499,14506,14847,15390],0); -ELEMENTS[57927] = Fluid3D([18431,18240,18276,18287],0); -ELEMENTS[57928] = Fluid3D([3533,3514,3375,3075],0); -ELEMENTS[57929] = Fluid3D([12857,13067,13710,12748],0); -ELEMENTS[57930] = Fluid3D([3946,3869,4404,4507],0); -ELEMENTS[57931] = Fluid3D([4414,4449,4035,4318],0); -ELEMENTS[57932] = Fluid3D([8174,8299,9217,8745],0); -ELEMENTS[57933] = Fluid3D([14580,14885,14145,14765],0); -ELEMENTS[57934] = Fluid3D([8097,8803,8347,7789],0); -ELEMENTS[57935] = Fluid3D([8097,8803,7789,8416],0); -ELEMENTS[57936] = Fluid3D([7789,8097,8416,7569],0); -ELEMENTS[57937] = Fluid3D([7789,8097,7569,6992],0); -ELEMENTS[57938] = Fluid3D([7789,8097,6992,7249],0); -ELEMENTS[57939] = Fluid3D([7789,8097,7249,8347],0); -ELEMENTS[57940] = Fluid3D([16916,16833,16687,17129],0); -ELEMENTS[57941] = Fluid3D([12081,11667,10925,12143],0); -ELEMENTS[57942] = Fluid3D([11667,10925,12143,11291],0); -ELEMENTS[57943] = Fluid3D([15991,16598,16481,16057],0); -ELEMENTS[57944] = Fluid3D([14509,14643,14040,15045],0); -ELEMENTS[57945] = Fluid3D([10442,11070,9809,10361],0); -ELEMENTS[57946] = Fluid3D([8354,7822,7955,7128],0); -ELEMENTS[57947] = Fluid3D([14596,14338,13693,14275],0); -ELEMENTS[57948] = Fluid3D([14596,14338,14275,15053],0); -ELEMENTS[57949] = Fluid3D([11207,11732,11955,12156],0); -ELEMENTS[57950] = Fluid3D([8956,9309,9884,9547],0); -ELEMENTS[57951] = Fluid3D([3846,3503,4067,4000],0); -ELEMENTS[57952] = Fluid3D([5703,5442,5992,6204],0); -ELEMENTS[57953] = Fluid3D([5992,5703,6204,6556],0); -ELEMENTS[57954] = Fluid3D([15898,15476,15700,16047],0); -ELEMENTS[57955] = Fluid3D([17311,17554,17219,17222],0); -ELEMENTS[57956] = Fluid3D([17311,17554,17222,17333],0); -ELEMENTS[57957] = Fluid3D([17219,17311,17222,16786],0); -ELEMENTS[57958] = Fluid3D([18489,18574,18534,18565],0); -ELEMENTS[57959] = Fluid3D([18489,18574,18565,18555],0); -ELEMENTS[57960] = Fluid3D([8462,7664,7574,7542],0); -ELEMENTS[57961] = Fluid3D([15585,15436,15378,14495],0); -ELEMENTS[57962] = Fluid3D([4267,4340,3945,3717],0); -ELEMENTS[57963] = Fluid3D([6821,6427,6126,7034],0); -ELEMENTS[57964] = Fluid3D([17013,16486,16854,16827],0); -ELEMENTS[57965] = Fluid3D([18237,18158,18015,18266],0); -ELEMENTS[57966] = Fluid3D([14004,14713,13563,14397],0); -ELEMENTS[57967] = Fluid3D([8285,8144,8390,9122],0); -ELEMENTS[57968] = Fluid3D([8285,8144,9122,9026],0); -ELEMENTS[57969] = Fluid3D([8285,8144,9026,8548],0); -ELEMENTS[57970] = Fluid3D([8144,9026,8548,8995],0); -ELEMENTS[57971] = Fluid3D([9026,8548,8995,9814],0); -ELEMENTS[57972] = Fluid3D([14432,15145,15064,15021],0); -ELEMENTS[57973] = Fluid3D([15064,14432,15021,14407],0); -ELEMENTS[57974] = Fluid3D([12288,12907,13322,13136],0); -ELEMENTS[57975] = Fluid3D([8833,8740,9508,9822],0); -ELEMENTS[57976] = Fluid3D([11663,11942,10815,12023],0); -ELEMENTS[57977] = Fluid3D([15767,15097,15586,14849],0); -ELEMENTS[57978] = Fluid3D([15103,14899,14490,14646],0); -ELEMENTS[57979] = Fluid3D([14490,15103,14646,14884],0); -ELEMENTS[57980] = Fluid3D([14490,15103,14884,15337],0); -ELEMENTS[57981] = Fluid3D([14646,14490,14884,14020],0); -ELEMENTS[57982] = Fluid3D([14490,14884,14020,14582],0); -ELEMENTS[57983] = Fluid3D([14020,14490,14582,14252],0); -ELEMENTS[57984] = Fluid3D([14490,14582,14252,15337],0); -ELEMENTS[57985] = Fluid3D([14884,14020,14582,14230],0); -ELEMENTS[57986] = Fluid3D([14020,14582,14230,14252],0); -ELEMENTS[57987] = Fluid3D([14582,14884,14230,15114],0); -ELEMENTS[57988] = Fluid3D([14884,14020,14230,14660],0); -ELEMENTS[57989] = Fluid3D([14582,14230,14252,14309],0); -ELEMENTS[57990] = Fluid3D([14582,14230,14309,15114],0); -ELEMENTS[57991] = Fluid3D([14490,14884,14582,15337],0); -ELEMENTS[57992] = Fluid3D([14884,14582,15337,15114],0); -ELEMENTS[57993] = Fluid3D([14984,14566,15418,14271],0); -ELEMENTS[57994] = Fluid3D([14984,14566,14271,14382],0); -ELEMENTS[57995] = Fluid3D([8512,8138,9206,9214],0); -ELEMENTS[57996] = Fluid3D([7996,7951,7498,7218],0); -ELEMENTS[57997] = Fluid3D([17849,18070,17682,17962],0); -ELEMENTS[57998] = Fluid3D([17682,17849,17962,17713],0); -ELEMENTS[57999] = Fluid3D([17682,17849,17713,17583],0); -ELEMENTS[58000] = Fluid3D([17962,17682,17713,17633],0); -ELEMENTS[58001] = Fluid3D([10426,10050,11058,10391],0); -ELEMENTS[58002] = Fluid3D([6946,6888,7450,7818],0); -ELEMENTS[58003] = Fluid3D([3151,3179,3450,3116],0); -ELEMENTS[58004] = Fluid3D([16440,16738,16173,16612],0); -ELEMENTS[58005] = Fluid3D([13009,13257,12721,12144],0); -ELEMENTS[58006] = Fluid3D([14300,14259,15022,14598],0); -ELEMENTS[58007] = Fluid3D([14300,14259,14598,13428],0); -ELEMENTS[58008] = Fluid3D([13755,13049,12949,13279],0); -ELEMENTS[58009] = Fluid3D([10268,9476,9552,9175],0); -ELEMENTS[58010] = Fluid3D([4893,4720,4294,4281],0); -ELEMENTS[58011] = Fluid3D([9179,9665,9478,8686],0); -ELEMENTS[58012] = Fluid3D([12174,12051,12474,11709],0); -ELEMENTS[58013] = Fluid3D([11757,11131,12014,10680],0); -ELEMENTS[58014] = Fluid3D([6736,6842,7666,7466],0); -ELEMENTS[58015] = Fluid3D([14579,15189,15182,14937],0); -ELEMENTS[58016] = Fluid3D([12209,11920,11162,11332],0); -ELEMENTS[58017] = Fluid3D([12506,13296,12799,12520],0); -ELEMENTS[58018] = Fluid3D([11731,11352,12436,11579],0); -ELEMENTS[58019] = Fluid3D([6998,6476,7392,7266],0); -ELEMENTS[58020] = Fluid3D([6476,7392,7266,6788],0); -ELEMENTS[58021] = Fluid3D([3252,3596,3629,3546],0); -ELEMENTS[58022] = Fluid3D([6171,5614,6076,6259],0); -ELEMENTS[58023] = Fluid3D([4182,3801,3717,4035],0); -ELEMENTS[58024] = Fluid3D([9686,10155,10497,10221],0); -ELEMENTS[58025] = Fluid3D([14085,14358,13776,14816],0); -ELEMENTS[58026] = Fluid3D([14476,15212,15169,15300],0); -ELEMENTS[58027] = Fluid3D([16581,16590,16482,16088],0); -ELEMENTS[58028] = Fluid3D([2282,2057,2179,2046],0); -ELEMENTS[58029] = Fluid3D([2282,2057,2046,2240],0); -ELEMENTS[58030] = Fluid3D([2046,2282,2240,2170],0); -ELEMENTS[58031] = Fluid3D([2240,2046,2170,2062],0); -ELEMENTS[58032] = Fluid3D([16706,16825,16405,16002],0); -ELEMENTS[58033] = Fluid3D([8493,8272,9148,8027],0); -ELEMENTS[58034] = Fluid3D([8493,8272,8027,7768],0); -ELEMENTS[58035] = Fluid3D([16095,15897,16038,15538],0); -ELEMENTS[58036] = Fluid3D([16530,16659,16672,17164],0); -ELEMENTS[58037] = Fluid3D([15038,14365,15105,15469],0); -ELEMENTS[58038] = Fluid3D([18222,18036,17993,18099],0); -ELEMENTS[58039] = Fluid3D([5636,5309,5228,5139],0); -ELEMENTS[58040] = Fluid3D([15159,15008,14315,15161],0); -ELEMENTS[58041] = Fluid3D([16981,17250,16917,17508],0); -ELEMENTS[58042] = Fluid3D([15269,14504,14849,14564],0); -ELEMENTS[58043] = Fluid3D([3342,3096,3103,3138],0); -ELEMENTS[58044] = Fluid3D([14370,13786,14331,14732],0); -ELEMENTS[58045] = Fluid3D([7031,7105,6515,6531],0); -ELEMENTS[58046] = Fluid3D([2214,2300,2257,2078],0); -ELEMENTS[58047] = Fluid3D([2214,2300,2078,2041],0); -ELEMENTS[58048] = Fluid3D([2257,2214,2078,2032],0); -ELEMENTS[58049] = Fluid3D([2078,2257,2032,1999],0); -ELEMENTS[58050] = Fluid3D([2032,2078,1999,1911],0); -ELEMENTS[58051] = Fluid3D([2078,1999,1911,2041],0); -ELEMENTS[58052] = Fluid3D([1911,2078,2041,2214],0); -ELEMENTS[58053] = Fluid3D([2300,2257,2078,2464],0); -ELEMENTS[58054] = Fluid3D([2078,2257,1999,2174],0); -ELEMENTS[58055] = Fluid3D([1999,2078,2174,2215],0); -ELEMENTS[58056] = Fluid3D([8049,7690,7568,8669],0); -ELEMENTS[58057] = Fluid3D([11965,12100,11997,13036],0); -ELEMENTS[58058] = Fluid3D([4251,4033,3679,3882],0); -ELEMENTS[58059] = Fluid3D([3679,4251,3882,4080],0); -ELEMENTS[58060] = Fluid3D([4033,3679,3882,3636],0); -ELEMENTS[58061] = Fluid3D([3679,3882,3636,3305],0); -ELEMENTS[58062] = Fluid3D([3679,3882,3305,3375],0); -ELEMENTS[58063] = Fluid3D([3679,3882,3375,3748],0); -ELEMENTS[58064] = Fluid3D([3882,3679,4080,3748],0); -ELEMENTS[58065] = Fluid3D([4251,4033,3882,3809],0); -ELEMENTS[58066] = Fluid3D([17236,16889,17113,17532],0); -ELEMENTS[58067] = Fluid3D([10326,9262,9414,10110],0); -ELEMENTS[58068] = Fluid3D([9414,10326,10110,10015],0); -ELEMENTS[58069] = Fluid3D([11562,11520,11171,10157],0); -ELEMENTS[58070] = Fluid3D([14645,14383,13811,14400],0); -ELEMENTS[58071] = Fluid3D([8305,7408,7567,7693],0); -ELEMENTS[58072] = Fluid3D([4963,4440,4910,4719],0); -ELEMENTS[58073] = Fluid3D([4121,4619,3905,4237],0); -ELEMENTS[58074] = Fluid3D([17345,16930,17212,16728],0); -ELEMENTS[58075] = Fluid3D([16364,15946,16408,15892],0); -ELEMENTS[58076] = Fluid3D([16528,16397,16837,16326],0); -ELEMENTS[58077] = Fluid3D([9330,9704,10043,10612],0); -ELEMENTS[58078] = Fluid3D([8399,8124,9286,8228],0); -ELEMENTS[58079] = Fluid3D([3479,3224,3367,2938],0); -ELEMENTS[58080] = Fluid3D([1756,1854,1680,1828],0); -ELEMENTS[58081] = Fluid3D([5892,6164,6402,6530],0); -ELEMENTS[58082] = Fluid3D([13177,13830,14351,13622],0); -ELEMENTS[58083] = Fluid3D([15931,16188,15648,15749],0); -ELEMENTS[58084] = Fluid3D([5748,5105,5612,5106],0); -ELEMENTS[58085] = Fluid3D([13560,13024,12813,13872],0); -ELEMENTS[58086] = Fluid3D([9294,9613,9062,10207],0); -ELEMENTS[58087] = Fluid3D([14177,14277,13809,14941],0); -ELEMENTS[58088] = Fluid3D([12497,13377,13301,13416],0); -ELEMENTS[58089] = Fluid3D([13377,13301,13416,14483],0); -ELEMENTS[58090] = Fluid3D([12497,13377,13416,13238],0); -ELEMENTS[58091] = Fluid3D([13377,13416,13238,14273],0); -ELEMENTS[58092] = Fluid3D([13377,13416,14273,14483],0); -ELEMENTS[58093] = Fluid3D([17313,17727,17471,17293],0); -ELEMENTS[58094] = Fluid3D([17471,17313,17293,16987],0); -ELEMENTS[58095] = Fluid3D([12186,11567,11094,11489],0); -ELEMENTS[58096] = Fluid3D([14795,14392,13797,13882],0); -ELEMENTS[58097] = Fluid3D([5172,5578,5740,5133],0); -ELEMENTS[58098] = Fluid3D([3867,3725,3370,3693],0); -ELEMENTS[58099] = Fluid3D([5419,5674,6150,5933],0); -ELEMENTS[58100] = Fluid3D([5419,5674,5933,5479],0); -ELEMENTS[58101] = Fluid3D([5674,6150,5933,6013],0); -ELEMENTS[58102] = Fluid3D([5933,5674,6013,5479],0); -ELEMENTS[58103] = Fluid3D([6013,5933,5479,6443],0); -ELEMENTS[58104] = Fluid3D([6013,5933,6443,6150],0); -ELEMENTS[58105] = Fluid3D([5933,6443,6150,6406],0); -ELEMENTS[58106] = Fluid3D([6150,5419,5933,6406],0); -ELEMENTS[58107] = Fluid3D([5933,5479,6443,5943],0); -ELEMENTS[58108] = Fluid3D([6443,5933,5943,6406],0); -ELEMENTS[58109] = Fluid3D([5933,5479,5943,5419],0); -ELEMENTS[58110] = Fluid3D([5943,5933,5419,6406],0); -ELEMENTS[58111] = Fluid3D([6083,6676,6233,6224],0); -ELEMENTS[58112] = Fluid3D([10275,10698,11445,11028],0); -ELEMENTS[58113] = Fluid3D([17765,17490,17649,17384],0); -ELEMENTS[58114] = Fluid3D([3485,3885,3826,3560],0); -ELEMENTS[58115] = Fluid3D([11618,11067,11925,12166],0); -ELEMENTS[58116] = Fluid3D([11925,11618,12166,12693],0); -ELEMENTS[58117] = Fluid3D([11067,11925,12166,11649],0); -ELEMENTS[58118] = Fluid3D([12166,11925,12693,13209],0); -ELEMENTS[58119] = Fluid3D([11925,12166,11649,12722],0); -ELEMENTS[58120] = Fluid3D([11014,11315,11246,12181],0); -ELEMENTS[58121] = Fluid3D([14867,15474,14868,15127],0); -ELEMENTS[58122] = Fluid3D([14867,15474,15127,15538],0); -ELEMENTS[58123] = Fluid3D([15474,15127,15538,16038],0); -ELEMENTS[58124] = Fluid3D([15474,14868,15127,15596],0); -ELEMENTS[58125] = Fluid3D([15127,15538,16038,15897],0); -ELEMENTS[58126] = Fluid3D([15127,14867,15538,14799],0); -ELEMENTS[58127] = Fluid3D([15538,15127,14799,15277],0); -ELEMENTS[58128] = Fluid3D([15538,15127,15277,15897],0); -ELEMENTS[58129] = Fluid3D([14799,15538,15277,15570],0); -ELEMENTS[58130] = Fluid3D([15538,15277,15570,16095],0); -ELEMENTS[58131] = Fluid3D([15127,14799,15277,14851],0); -ELEMENTS[58132] = Fluid3D([17594,17631,17786,17951],0); -ELEMENTS[58133] = Fluid3D([5463,5623,5713,5143],0); -ELEMENTS[58134] = Fluid3D([16172,15865,15674,16138],0); -ELEMENTS[58135] = Fluid3D([15674,16172,16138,16164],0); -ELEMENTS[58136] = Fluid3D([12978,13703,13702,13907],0); -ELEMENTS[58137] = Fluid3D([10035,10232,10830,9527],0); -ELEMENTS[58138] = Fluid3D([14257,14575,15193,14515],0); -ELEMENTS[58139] = Fluid3D([14257,14575,14515,13985],0); -ELEMENTS[58140] = Fluid3D([14575,14515,13985,14946],0); -ELEMENTS[58141] = Fluid3D([14575,15193,14515,15231],0); -ELEMENTS[58142] = Fluid3D([16148,16544,16263,15701],0); -ELEMENTS[58143] = Fluid3D([11525,12109,12589,11411],0); -ELEMENTS[58144] = Fluid3D([16428,15961,16438,15806],0); -ELEMENTS[58145] = Fluid3D([5151,4992,4999,4558],0); -ELEMENTS[58146] = Fluid3D([4992,4999,4558,4288],0); -ELEMENTS[58147] = Fluid3D([5786,6335,6164,5751],0); -ELEMENTS[58148] = Fluid3D([11749,11453,12319,12748],0); -ELEMENTS[58149] = Fluid3D([2283,2409,2606,2550],0); -ELEMENTS[58150] = Fluid3D([9464,8566,9189,9781],0); -ELEMENTS[58151] = Fluid3D([14819,15071,15070,15597],0); -ELEMENTS[58152] = Fluid3D([17510,17354,17591,17791],0); -ELEMENTS[58153] = Fluid3D([17510,17354,17791,17474],0); -ELEMENTS[58154] = Fluid3D([17510,17354,17474,17215],0); -ELEMENTS[58155] = Fluid3D([17354,17791,17474,17623],0); -ELEMENTS[58156] = Fluid3D([17791,17474,17623,17869],0); -ELEMENTS[58157] = Fluid3D([17623,17791,17869,18080],0); -ELEMENTS[58158] = Fluid3D([17791,17474,17869,17816],0); -ELEMENTS[58159] = Fluid3D([17869,17791,17816,18030],0); -ELEMENTS[58160] = Fluid3D([17869,17791,18030,18080],0); -ELEMENTS[58161] = Fluid3D([17474,17510,17215,17617],0); -ELEMENTS[58162] = Fluid3D([17215,17474,17617,17695],0); -ELEMENTS[58163] = Fluid3D([17474,17510,17617,17816],0); -ELEMENTS[58164] = Fluid3D([17791,17510,17474,17816],0); -ELEMENTS[58165] = Fluid3D([17791,17510,17816,17591],0); -ELEMENTS[58166] = Fluid3D([17474,17617,17695,17869],0); -ELEMENTS[58167] = Fluid3D([17474,17617,17869,17816],0); -ELEMENTS[58168] = Fluid3D([17510,17617,17816,17566],0); -ELEMENTS[58169] = Fluid3D([17816,17510,17566,17766],0); -ELEMENTS[58170] = Fluid3D([17354,17474,17215,17241],0); -ELEMENTS[58171] = Fluid3D([17474,17215,17241,17695],0); -ELEMENTS[58172] = Fluid3D([17791,17816,18030,17591],0); -ELEMENTS[58173] = Fluid3D([17354,17791,17623,17638],0); -ELEMENTS[58174] = Fluid3D([17354,17591,17791,17638],0); -ELEMENTS[58175] = Fluid3D([17474,17354,17623,17241],0); -ELEMENTS[58176] = Fluid3D([17474,17623,17869,17695],0); -ELEMENTS[58177] = Fluid3D([4591,4207,4907,4552],0); -ELEMENTS[58178] = Fluid3D([8575,8151,7539,8012],0); -ELEMENTS[58179] = Fluid3D([8575,8151,8012,8699],0); -ELEMENTS[58180] = Fluid3D([8012,8575,8699,7983],0); -ELEMENTS[58181] = Fluid3D([8151,7539,8012,7143],0); -ELEMENTS[58182] = Fluid3D([7539,8575,8012,7983],0); -ELEMENTS[58183] = Fluid3D([11629,11328,10621,11762],0); -ELEMENTS[58184] = Fluid3D([13381,14056,14323,13341],0); -ELEMENTS[58185] = Fluid3D([5752,6066,6372,6553],0); -ELEMENTS[58186] = Fluid3D([14676,14940,15271,15335],0); -ELEMENTS[58187] = Fluid3D([14676,14940,15335,14382],0); -ELEMENTS[58188] = Fluid3D([13030,13076,12128,12745],0); -ELEMENTS[58189] = Fluid3D([13030,13076,12745,13825],0); -ELEMENTS[58190] = Fluid3D([10504,11109,11220,11421],0); -ELEMENTS[58191] = Fluid3D([17503,17784,17785,17384],0); -ELEMENTS[58192] = Fluid3D([10600,10634,11233,11656],0); -ELEMENTS[58193] = Fluid3D([11721,12645,12348,12761],0); -ELEMENTS[58194] = Fluid3D([10889,10558,9904,10284],0); -ELEMENTS[58195] = Fluid3D([3361,3120,3263,2998],0); -ELEMENTS[58196] = Fluid3D([13051,12994,12592,12325],0); -ELEMENTS[58197] = Fluid3D([2749,2899,3064,2626],0); -ELEMENTS[58198] = Fluid3D([16860,16414,16979,16708],0); -ELEMENTS[58199] = Fluid3D([16860,16414,16708,16280],0); -ELEMENTS[58200] = Fluid3D([16414,16708,16280,16327],0); -ELEMENTS[58201] = Fluid3D([16979,16860,16708,16894],0); -ELEMENTS[58202] = Fluid3D([16860,16708,16894,16863],0); -ELEMENTS[58203] = Fluid3D([16860,16708,16863,16280],0); -ELEMENTS[58204] = Fluid3D([16708,16894,16863,16280],0); -ELEMENTS[58205] = Fluid3D([16708,16894,16280,16798],0); -ELEMENTS[58206] = Fluid3D([16708,16894,16798,16979],0); -ELEMENTS[58207] = Fluid3D([16414,16979,16708,16327],0); -ELEMENTS[58208] = Fluid3D([9865,9760,9200,9084],0); -ELEMENTS[58209] = Fluid3D([12039,12196,12519,13244],0); -ELEMENTS[58210] = Fluid3D([12389,12222,12271,11975],0); -ELEMENTS[58211] = Fluid3D([11450,10716,10830,10543],0); -ELEMENTS[58212] = Fluid3D([10288,10861,9906,11134],0); -ELEMENTS[58213] = Fluid3D([16605,16316,16162,15767],0); -ELEMENTS[58214] = Fluid3D([13090,12617,13409,13931],0); -ELEMENTS[58215] = Fluid3D([3882,3438,3779,3305],0); -ELEMENTS[58216] = Fluid3D([15790,15873,15502,16257],0); -ELEMENTS[58217] = Fluid3D([11781,12687,12669,12758],0); -ELEMENTS[58218] = Fluid3D([17664,17877,17727,18012],0); -ELEMENTS[58219] = Fluid3D([12152,13080,12483,12514],0); -ELEMENTS[58220] = Fluid3D([6495,7266,6788,6476],0); -ELEMENTS[58221] = Fluid3D([6495,7266,6476,6950],0); -ELEMENTS[58222] = Fluid3D([16543,16536,16730,16453],0); -ELEMENTS[58223] = Fluid3D([17807,17758,17438,17605],0); -ELEMENTS[58224] = Fluid3D([15325,14622,15096,15619],0); -ELEMENTS[58225] = Fluid3D([14366,15139,14422,14879],0); -ELEMENTS[58226] = Fluid3D([14366,15139,14879,14997],0); -ELEMENTS[58227] = Fluid3D([9854,8996,9096,9240],0); -ELEMENTS[58228] = Fluid3D([9096,9854,9240,10209],0); -ELEMENTS[58229] = Fluid3D([9854,9240,10209,8595],0); -ELEMENTS[58230] = Fluid3D([8698,8794,9702,9097],0); -ELEMENTS[58231] = Fluid3D([3860,3507,3378,3431],0); -ELEMENTS[58232] = Fluid3D([8176,8281,8428,7806],0); -ELEMENTS[58233] = Fluid3D([8176,8281,7806,7608],0); -ELEMENTS[58234] = Fluid3D([8281,8428,7806,8547],0); -ELEMENTS[58235] = Fluid3D([8281,7806,7608,8547],0); -ELEMENTS[58236] = Fluid3D([5605,5033,4884,4835],0); -ELEMENTS[58237] = Fluid3D([11860,11226,11549,11395],0); -ELEMENTS[58238] = Fluid3D([18238,18007,18212,17966],0); -ELEMENTS[58239] = Fluid3D([10874,11601,10699,11424],0); -ELEMENTS[58240] = Fluid3D([10689,10306,9725,9840],0); -ELEMENTS[58241] = Fluid3D([10306,9725,9840,9184],0); -ELEMENTS[58242] = Fluid3D([10689,10306,9840,10144],0); -ELEMENTS[58243] = Fluid3D([9840,10306,9184,9943],0); -ELEMENTS[58244] = Fluid3D([9840,10306,9943,10144],0); -ELEMENTS[58245] = Fluid3D([9725,9840,9184,9594],0); -ELEMENTS[58246] = Fluid3D([9840,9184,9594,10144],0); -ELEMENTS[58247] = Fluid3D([9840,9184,10144,9758],0); -ELEMENTS[58248] = Fluid3D([9594,9840,10144,10195],0); -ELEMENTS[58249] = Fluid3D([9594,9840,10195,9725],0); -ELEMENTS[58250] = Fluid3D([9840,9184,9758,9943],0); -ELEMENTS[58251] = Fluid3D([9840,10144,10195,10689],0); -ELEMENTS[58252] = Fluid3D([10144,9840,9758,9943],0); -ELEMENTS[58253] = Fluid3D([10195,9840,10689,9725],0); -ELEMENTS[58254] = Fluid3D([10144,9594,10195,10581],0); -ELEMENTS[58255] = Fluid3D([9594,10195,10581,10013],0); -ELEMENTS[58256] = Fluid3D([9594,10195,10013,9050],0); -ELEMENTS[58257] = Fluid3D([9184,9758,9943,8818],0); -ELEMENTS[58258] = Fluid3D([9758,9943,8818,9386],0); -ELEMENTS[58259] = Fluid3D([9758,9943,9386,10371],0); -ELEMENTS[58260] = Fluid3D([9758,9943,10371,10770],0); -ELEMENTS[58261] = Fluid3D([9758,9943,10770,10144],0); -ELEMENTS[58262] = Fluid3D([9943,8818,9386,8897],0); -ELEMENTS[58263] = Fluid3D([8756,9260,9531,9413],0); -ELEMENTS[58264] = Fluid3D([14565,14278,14171,13768],0); -ELEMENTS[58265] = Fluid3D([5789,5489,6193,6234],0); -ELEMENTS[58266] = Fluid3D([12417,13157,13272,13652],0); -ELEMENTS[58267] = Fluid3D([17033,17334,17463,17742],0); -ELEMENTS[58268] = Fluid3D([10562,10013,9775,9486],0); -ELEMENTS[58269] = Fluid3D([10013,9775,9486,9050],0); -ELEMENTS[58270] = Fluid3D([9775,10562,9486,10577],0); -ELEMENTS[58271] = Fluid3D([9775,9486,9050,8541],0); -ELEMENTS[58272] = Fluid3D([9775,9486,8541,9795],0); -ELEMENTS[58273] = Fluid3D([9775,9486,9795,10034],0); -ELEMENTS[58274] = Fluid3D([9795,9775,10034,11273],0); -ELEMENTS[58275] = Fluid3D([9775,9486,10034,10577],0); -ELEMENTS[58276] = Fluid3D([9486,9795,10034,9002],0); -ELEMENTS[58277] = Fluid3D([10034,9775,10577,11273],0); -ELEMENTS[58278] = Fluid3D([12313,13187,13058,13576],0); -ELEMENTS[58279] = Fluid3D([2583,2607,2355,2635],0); -ELEMENTS[58280] = Fluid3D([18155,17811,17939,17832],0); -ELEMENTS[58281] = Fluid3D([8752,8878,7882,8289],0); -ELEMENTS[58282] = Fluid3D([13844,13661,13462,12993],0); -ELEMENTS[58283] = Fluid3D([18054,18268,17993,18324],0); -ELEMENTS[58284] = Fluid3D([3418,3721,3506,3598],0); -ELEMENTS[58285] = Fluid3D([14832,15281,15020,15665],0); -ELEMENTS[58286] = Fluid3D([2318,2118,2272,2122],0); -ELEMENTS[58287] = Fluid3D([13038,12583,13422,13483],0); -ELEMENTS[58288] = Fluid3D([13374,14151,14285,14373],0); -ELEMENTS[58289] = Fluid3D([11658,11308,10539,10906],0); -ELEMENTS[58290] = Fluid3D([11658,11308,10906,11184],0); -ELEMENTS[58291] = Fluid3D([11308,10906,11184,10221],0); -ELEMENTS[58292] = Fluid3D([10906,11184,10221,11172],0); -ELEMENTS[58293] = Fluid3D([10906,11184,11172,11658],0); -ELEMENTS[58294] = Fluid3D([10221,10906,11172,10497],0); -ELEMENTS[58295] = Fluid3D([11172,10906,11658,10497],0); -ELEMENTS[58296] = Fluid3D([11308,10539,10906,10221],0); -ELEMENTS[58297] = Fluid3D([10539,10906,10221,10497],0); -ELEMENTS[58298] = Fluid3D([10539,11658,10906,10497],0); -ELEMENTS[58299] = Fluid3D([10403,9770,9266,9968],0); -ELEMENTS[58300] = Fluid3D([10403,9770,9968,11256],0); -ELEMENTS[58301] = Fluid3D([11110,10356,11498,10529],0); -ELEMENTS[58302] = Fluid3D([8533,9229,8800,9003],0); -ELEMENTS[58303] = Fluid3D([9229,8800,9003,9748],0); -ELEMENTS[58304] = Fluid3D([16246,16032,16450,16783],0); -ELEMENTS[58305] = Fluid3D([12088,11164,11576,11774],0); -ELEMENTS[58306] = Fluid3D([18144,18303,18247,18302],0); -ELEMENTS[58307] = Fluid3D([18144,18303,18302,18351],0); -ELEMENTS[58308] = Fluid3D([18303,18247,18302,18437],0); -ELEMENTS[58309] = Fluid3D([18302,18303,18437,18478],0); -ELEMENTS[58310] = Fluid3D([18302,18303,18478,18351],0); -ELEMENTS[58311] = Fluid3D([10325,11175,11007,10847],0); -ELEMENTS[58312] = Fluid3D([15290,15902,15542,15433],0); -ELEMENTS[58313] = Fluid3D([10961,11588,11272,11897],0); -ELEMENTS[58314] = Fluid3D([8850,9358,9481,10093],0); -ELEMENTS[58315] = Fluid3D([6803,7408,6813,7869],0); -ELEMENTS[58316] = Fluid3D([13182,13813,13533,13694],0); -ELEMENTS[58317] = Fluid3D([15403,16013,15622,15651],0); -ELEMENTS[58318] = Fluid3D([15403,16013,15651,15986],0); -ELEMENTS[58319] = Fluid3D([15622,15403,15651,15216],0); -ELEMENTS[58320] = Fluid3D([15651,15403,15986,15398],0); -ELEMENTS[58321] = Fluid3D([15986,15651,15398,15626],0); -ELEMENTS[58322] = Fluid3D([17313,17664,17727,17769],0); -ELEMENTS[58323] = Fluid3D([16776,16768,17120,17033],0); -ELEMENTS[58324] = Fluid3D([16776,16768,17033,16674],0); -ELEMENTS[58325] = Fluid3D([16768,17033,16674,17138],0); -ELEMENTS[58326] = Fluid3D([17120,16776,17033,16994],0); -ELEMENTS[58327] = Fluid3D([17120,16776,16994,16465],0); -ELEMENTS[58328] = Fluid3D([16776,17033,16994,16943],0); -ELEMENTS[58329] = Fluid3D([16994,16776,16943,16468],0); -ELEMENTS[58330] = Fluid3D([16776,16943,16468,16913],0); -ELEMENTS[58331] = Fluid3D([16943,16994,16468,16772],0); -ELEMENTS[58332] = Fluid3D([16943,16468,16913,16500],0); -ELEMENTS[58333] = Fluid3D([16943,16468,16500,16778],0); -ELEMENTS[58334] = Fluid3D([16943,16468,16778,16772],0); -ELEMENTS[58335] = Fluid3D([16776,16943,16913,17033],0); -ELEMENTS[58336] = Fluid3D([16994,16776,16468,16465],0); -ELEMENTS[58337] = Fluid3D([16768,17120,17033,17138],0); -ELEMENTS[58338] = Fluid3D([16674,16768,17138,16535],0); -ELEMENTS[58339] = Fluid3D([16674,16768,16535,16240],0); -ELEMENTS[58340] = Fluid3D([16768,16535,16240,16950],0); -ELEMENTS[58341] = Fluid3D([16768,16535,16950,17138],0); -ELEMENTS[58342] = Fluid3D([16950,16768,17138,17120],0); -ELEMENTS[58343] = Fluid3D([16535,16950,17138,16705],0); -ELEMENTS[58344] = Fluid3D([16535,16950,16705,16704],0); -ELEMENTS[58345] = Fluid3D([16535,16950,16704,16240],0); -ELEMENTS[58346] = Fluid3D([17033,16776,16674,16474],0); -ELEMENTS[58347] = Fluid3D([16431,16713,16125,16401],0); -ELEMENTS[58348] = Fluid3D([16431,16713,16401,16650],0); -ELEMENTS[58349] = Fluid3D([16713,16125,16401,16667],0); -ELEMENTS[58350] = Fluid3D([16401,16713,16667,16650],0); -ELEMENTS[58351] = Fluid3D([16125,16431,16401,16098],0); -ELEMENTS[58352] = Fluid3D([16401,16125,16098,16394],0); -ELEMENTS[58353] = Fluid3D([16098,16401,16394,16650],0); -ELEMENTS[58354] = Fluid3D([16098,16401,16650,16338],0); -ELEMENTS[58355] = Fluid3D([16401,16394,16650,16667],0); -ELEMENTS[58356] = Fluid3D([16401,16650,16338,16431],0); -ELEMENTS[58357] = Fluid3D([16098,16401,16338,16431],0); -ELEMENTS[58358] = Fluid3D([16401,16394,16667,16125],0); -ELEMENTS[58359] = Fluid3D([14106,13959,13884,12928],0); -ELEMENTS[58360] = Fluid3D([5321,5388,5379,6065],0); -ELEMENTS[58361] = Fluid3D([10109,10596,11118,11447],0); -ELEMENTS[58362] = Fluid3D([10642,10975,9871,10662],0); -ELEMENTS[58363] = Fluid3D([10642,10975,10662,11961],0); -ELEMENTS[58364] = Fluid3D([9871,10642,10662,9738],0); -ELEMENTS[58365] = Fluid3D([10642,10662,9738,10536],0); -ELEMENTS[58366] = Fluid3D([10642,10662,10536,11469],0); -ELEMENTS[58367] = Fluid3D([9738,10642,10536,9970],0); -ELEMENTS[58368] = Fluid3D([9738,10642,9970,10271],0); -ELEMENTS[58369] = Fluid3D([10642,10662,11469,11961],0); -ELEMENTS[58370] = Fluid3D([10536,9738,9970,9617],0); -ELEMENTS[58371] = Fluid3D([9738,9970,9617,8860],0); -ELEMENTS[58372] = Fluid3D([9738,9970,8860,8988],0); -ELEMENTS[58373] = Fluid3D([9871,10642,9738,10271],0); -ELEMENTS[58374] = Fluid3D([1862,1985,1969,2146],0); -ELEMENTS[58375] = Fluid3D([9509,9208,9285,8414],0); -ELEMENTS[58376] = Fluid3D([17890,17753,17740,17627],0); -ELEMENTS[58377] = Fluid3D([17740,17890,17627,18072],0); -ELEMENTS[58378] = Fluid3D([15804,15226,15593,15575],0); -ELEMENTS[58379] = Fluid3D([15226,15593,15575,14992],0); -ELEMENTS[58380] = Fluid3D([15804,15226,15575,15891],0); -ELEMENTS[58381] = Fluid3D([15226,15575,15891,15419],0); -ELEMENTS[58382] = Fluid3D([15575,15891,15419,16027],0); -ELEMENTS[58383] = Fluid3D([15575,15891,16027,16261],0); -ELEMENTS[58384] = Fluid3D([15575,15891,16261,15804],0); -ELEMENTS[58385] = Fluid3D([15575,15226,14992,15001],0); -ELEMENTS[58386] = Fluid3D([15575,15226,15001,15419],0); -ELEMENTS[58387] = Fluid3D([14992,15575,15001,14983],0); -ELEMENTS[58388] = Fluid3D([15001,15575,15419,15249],0); -ELEMENTS[58389] = Fluid3D([15419,15001,15249,14661],0); -ELEMENTS[58390] = Fluid3D([15001,15575,15249,14983],0); -ELEMENTS[58391] = Fluid3D([15249,15001,14983,14296],0); -ELEMENTS[58392] = Fluid3D([15249,15001,14296,14661],0); -ELEMENTS[58393] = Fluid3D([15001,14992,14983,14296],0); -ELEMENTS[58394] = Fluid3D([15001,14296,14661,14793],0); -ELEMENTS[58395] = Fluid3D([17778,17699,17718,17516],0); -ELEMENTS[58396] = Fluid3D([5473,5135,5397,4804],0); -ELEMENTS[58397] = Fluid3D([5397,5473,4804,4939],0); -ELEMENTS[58398] = Fluid3D([5397,5473,4939,5486],0); -ELEMENTS[58399] = Fluid3D([5397,5473,5486,5924],0); -ELEMENTS[58400] = Fluid3D([2635,2453,2477,2355],0); -ELEMENTS[58401] = Fluid3D([2477,2635,2355,2607],0); -ELEMENTS[58402] = Fluid3D([2477,2635,2607,2756],0); -ELEMENTS[58403] = Fluid3D([2635,2453,2355,2583],0); -ELEMENTS[58404] = Fluid3D([9237,9309,8955,8339],0); -ELEMENTS[58405] = Fluid3D([5077,4813,5100,5659],0); -ELEMENTS[58406] = Fluid3D([8376,7881,7330,7537],0); -ELEMENTS[58407] = Fluid3D([12437,12113,11901,11345],0); -ELEMENTS[58408] = Fluid3D([9903,10579,10534,10970],0); -ELEMENTS[58409] = Fluid3D([4580,4195,4746,4700],0); -ELEMENTS[58410] = Fluid3D([16828,17279,17030,17005],0); -ELEMENTS[58411] = Fluid3D([16828,17279,17005,17009],0); -ELEMENTS[58412] = Fluid3D([17279,17030,17005,16877],0); -ELEMENTS[58413] = Fluid3D([4341,3871,4092,4439],0); -ELEMENTS[58414] = Fluid3D([4341,3871,4439,4098],0); -ELEMENTS[58415] = Fluid3D([4439,4341,4098,4615],0); -ELEMENTS[58416] = Fluid3D([4092,4341,4439,4604],0); -ELEMENTS[58417] = Fluid3D([4439,4341,4615,4948],0); -ELEMENTS[58418] = Fluid3D([4439,4341,4948,4604],0); -ELEMENTS[58419] = Fluid3D([4341,4615,4948,4876],0); -ELEMENTS[58420] = Fluid3D([4615,4948,4876,5153],0); -ELEMENTS[58421] = Fluid3D([4948,4341,4876,4604],0); -ELEMENTS[58422] = Fluid3D([13425,13650,13935,12601],0); -ELEMENTS[58423] = Fluid3D([3881,3951,3604,3310],0); -ELEMENTS[58424] = Fluid3D([5999,5420,5242,5658],0); -ELEMENTS[58425] = Fluid3D([17774,17651,17390,17612],0); -ELEMENTS[58426] = Fluid3D([10250,9297,9604,9950],0); -ELEMENTS[58427] = Fluid3D([18543,18448,18521,18475],0); -ELEMENTS[58428] = Fluid3D([18521,18543,18475,18601],0); -ELEMENTS[58429] = Fluid3D([18475,18521,18601,18550],0); -ELEMENTS[58430] = Fluid3D([9386,9058,10003,9308],0); -ELEMENTS[58431] = Fluid3D([11826,12329,11960,11402],0); -ELEMENTS[58432] = Fluid3D([2320,2160,2124,2263],0); -ELEMENTS[58433] = Fluid3D([9967,11027,10897,10622],0); -ELEMENTS[58434] = Fluid3D([9967,11027,10622,10108],0); -ELEMENTS[58435] = Fluid3D([11027,10897,10622,11541],0); -ELEMENTS[58436] = Fluid3D([10897,9967,10622,10561],0); -ELEMENTS[58437] = Fluid3D([10622,10897,10561,11541],0); -ELEMENTS[58438] = Fluid3D([6500,5948,6584,7123],0); -ELEMENTS[58439] = Fluid3D([17761,17502,17695,17449],0); -ELEMENTS[58440] = Fluid3D([4276,4395,3930,4629],0); -ELEMENTS[58441] = Fluid3D([4754,4842,5379,4873],0); -ELEMENTS[58442] = Fluid3D([4349,3944,3813,3908],0); -ELEMENTS[58443] = Fluid3D([3944,3813,3908,3452],0); -ELEMENTS[58444] = Fluid3D([3908,3944,3452,3592],0); -ELEMENTS[58445] = Fluid3D([3908,3944,3592,4091],0); -ELEMENTS[58446] = Fluid3D([4349,3944,3908,4497],0); -ELEMENTS[58447] = Fluid3D([3908,3944,4091,4497],0); -ELEMENTS[58448] = Fluid3D([4762,5056,5342,5664],0); -ELEMENTS[58449] = Fluid3D([12114,12579,12899,12476],0); -ELEMENTS[58450] = Fluid3D([6179,6477,6109,5997],0); -ELEMENTS[58451] = Fluid3D([12005,11035,11719,11298],0); -ELEMENTS[58452] = Fluid3D([12005,11035,11298,11333],0); -ELEMENTS[58453] = Fluid3D([11035,11298,11333,10339],0); -ELEMENTS[58454] = Fluid3D([11035,11298,10339,10031],0); -ELEMENTS[58455] = Fluid3D([11035,11298,10031,10750],0); -ELEMENTS[58456] = Fluid3D([11035,11298,10750,11719],0); -ELEMENTS[58457] = Fluid3D([18531,18446,18540,18397],0); -ELEMENTS[58458] = Fluid3D([15941,16114,16334,15441],0); -ELEMENTS[58459] = Fluid3D([3673,3300,3623,3631],0); -ELEMENTS[58460] = Fluid3D([14261,14720,15185,14995],0); -ELEMENTS[58461] = Fluid3D([3250,3579,3623,3861],0); -ELEMENTS[58462] = Fluid3D([16398,16681,16737,16358],0); -ELEMENTS[58463] = Fluid3D([3409,3593,3818,3527],0); -ELEMENTS[58464] = Fluid3D([18505,18562,18469,18374],0); -ELEMENTS[58465] = Fluid3D([10021,9641,9065,10320],0); -ELEMENTS[58466] = Fluid3D([9188,8583,9507,8723],0); -ELEMENTS[58467] = Fluid3D([11161,10144,10756,10770],0); -ELEMENTS[58468] = Fluid3D([10144,10756,10770,9758],0); -ELEMENTS[58469] = Fluid3D([10756,10770,9758,10371],0); -ELEMENTS[58470] = Fluid3D([18256,18325,18150,18079],0); -ELEMENTS[58471] = Fluid3D([18051,18142,18323,18171],0); -ELEMENTS[58472] = Fluid3D([18323,18051,18171,18263],0); -ELEMENTS[58473] = Fluid3D([3084,3020,3376,3331],0); -ELEMENTS[58474] = Fluid3D([14064,13595,13679,12901],0); -ELEMENTS[58475] = Fluid3D([5294,5749,5162,5975],0); -ELEMENTS[58476] = Fluid3D([5294,5749,5975,5891],0); -ELEMENTS[58477] = Fluid3D([7868,8216,8176,7608],0); -ELEMENTS[58478] = Fluid3D([5592,5694,4994,5368],0); -ELEMENTS[58479] = Fluid3D([10953,12032,11779,11002],0); -ELEMENTS[58480] = Fluid3D([18530,18592,18605,18531],0); -ELEMENTS[58481] = Fluid3D([17642,17392,17413,17102],0); -ELEMENTS[58482] = Fluid3D([2366,2556,2317,2567],0); -ELEMENTS[58483] = Fluid3D([7693,8627,8447,8305],0); -ELEMENTS[58484] = Fluid3D([3464,3092,3286,3549],0); -ELEMENTS[58485] = Fluid3D([3464,3092,3549,3257],0); -ELEMENTS[58486] = Fluid3D([3286,3464,3549,3684],0); -ELEMENTS[58487] = Fluid3D([3549,3464,3257,3848],0); -ELEMENTS[58488] = Fluid3D([17302,17111,16997,16608],0); -ELEMENTS[58489] = Fluid3D([17299,17440,17145,17040],0); -ELEMENTS[58490] = Fluid3D([4666,4483,4427,4934],0); -ELEMENTS[58491] = Fluid3D([11940,11754,10987,12266],0); -ELEMENTS[58492] = Fluid3D([2043,1978,1885,2106],0); -ELEMENTS[58493] = Fluid3D([16844,17106,17124,16443],0); -ELEMENTS[58494] = Fluid3D([18524,18388,18387,18473],0); -ELEMENTS[58495] = Fluid3D([18387,18524,18473,18474],0); -ELEMENTS[58496] = Fluid3D([18473,18387,18474,18385],0); -ELEMENTS[58497] = Fluid3D([18473,18387,18385,18296],0); -ELEMENTS[58498] = Fluid3D([18473,18387,18296,18388],0); -ELEMENTS[58499] = Fluid3D([18387,18385,18296,18313],0); -ELEMENTS[58500] = Fluid3D([18387,18385,18313,18474],0); -ELEMENTS[58501] = Fluid3D([18296,18387,18313,18114],0); -ELEMENTS[58502] = Fluid3D([18385,18296,18313,18244],0); -ELEMENTS[58503] = Fluid3D([18385,18473,18296,18436],0); -ELEMENTS[58504] = Fluid3D([18385,18473,18436,18474],0); -ELEMENTS[58505] = Fluid3D([18296,18387,18114,18388],0); -ELEMENTS[58506] = Fluid3D([18385,18313,18474,18280],0); -ELEMENTS[58507] = Fluid3D([18385,18313,18280,18244],0); -ELEMENTS[58508] = Fluid3D([18280,18385,18244,18436],0); -ELEMENTS[58509] = Fluid3D([18280,18385,18436,18474],0); -ELEMENTS[58510] = Fluid3D([18385,18244,18436,18296],0); -ELEMENTS[58511] = Fluid3D([18313,18387,18474,18480],0); -ELEMENTS[58512] = Fluid3D([7111,6690,7471,6645],0); -ELEMENTS[58513] = Fluid3D([7111,6690,6645,6910],0); -ELEMENTS[58514] = Fluid3D([7742,7998,7379,8312],0); -ELEMENTS[58515] = Fluid3D([16137,15883,16269,15609],0); -ELEMENTS[58516] = Fluid3D([16137,15883,15609,15750],0); -ELEMENTS[58517] = Fluid3D([15609,16137,15750,16028],0); -ELEMENTS[58518] = Fluid3D([15883,15609,15750,15052],0); -ELEMENTS[58519] = Fluid3D([1729,1756,1659,1807],0); -ELEMENTS[58520] = Fluid3D([1729,1756,1807,1849],0); -ELEMENTS[58521] = Fluid3D([1756,1659,1807,1828],0); -ELEMENTS[58522] = Fluid3D([1659,1729,1807,1727],0); -ELEMENTS[58523] = Fluid3D([1807,1756,1828,1972],0); -ELEMENTS[58524] = Fluid3D([1828,1807,1972,1888],0); -ELEMENTS[58525] = Fluid3D([9851,10897,10779,10561],0); -ELEMENTS[58526] = Fluid3D([9851,10897,10561,9967],0); -ELEMENTS[58527] = Fluid3D([10897,10779,10561,11799],0); -ELEMENTS[58528] = Fluid3D([4781,4703,4310,4181],0); -ELEMENTS[58529] = Fluid3D([17990,18175,18030,17892],0); -ELEMENTS[58530] = Fluid3D([18175,18030,17892,17972],0); -ELEMENTS[58531] = Fluid3D([18030,17990,17892,17816],0); -ELEMENTS[58532] = Fluid3D([17990,18175,17892,18149],0); -ELEMENTS[58533] = Fluid3D([9981,10721,9757,9411],0); -ELEMENTS[58534] = Fluid3D([14980,14123,14417,14202],0); -ELEMENTS[58535] = Fluid3D([2880,3090,3235,3259],0); -ELEMENTS[58536] = Fluid3D([3235,2880,3259,3031],0); -ELEMENTS[58537] = Fluid3D([18589,18536,18610,18534],0); -ELEMENTS[58538] = Fluid3D([18536,18610,18534,18564],0); -ELEMENTS[58539] = Fluid3D([18610,18534,18564,18626],0); -ELEMENTS[58540] = Fluid3D([15285,14524,14852,14769],0); -ELEMENTS[58541] = Fluid3D([17696,17918,17888,17550],0); -ELEMENTS[58542] = Fluid3D([17696,17918,17550,17718],0); -ELEMENTS[58543] = Fluid3D([17550,17696,17718,17402],0); -ELEMENTS[58544] = Fluid3D([13958,14862,14497,14562],0); -ELEMENTS[58545] = Fluid3D([14862,14497,14562,15328],0); -ELEMENTS[58546] = Fluid3D([14497,13958,14562,13587],0); -ELEMENTS[58547] = Fluid3D([2738,3024,2989,3018],0); -ELEMENTS[58548] = Fluid3D([2989,2738,3018,2699],0); -ELEMENTS[58549] = Fluid3D([15149,14899,14690,14081],0); -ELEMENTS[58550] = Fluid3D([15280,15469,15029,14329],0); -ELEMENTS[58551] = Fluid3D([1767,1889,1821,1910],0); -ELEMENTS[58552] = Fluid3D([1767,1889,1910,1833],0); -ELEMENTS[58553] = Fluid3D([1910,1767,1833,1713],0); -ELEMENTS[58554] = Fluid3D([1889,1910,1833,1987],0); -ELEMENTS[58555] = Fluid3D([1833,1910,1713,1916],0); -ELEMENTS[58556] = Fluid3D([1833,1910,1916,1987],0); -ELEMENTS[58557] = Fluid3D([11646,10639,10702,11008],0); -ELEMENTS[58558] = Fluid3D([10702,11646,11008,11914],0); -ELEMENTS[58559] = Fluid3D([11646,11008,11914,11880],0); -ELEMENTS[58560] = Fluid3D([10639,10702,11008,9693],0); -ELEMENTS[58561] = Fluid3D([11646,10639,11008,11535],0); -ELEMENTS[58562] = Fluid3D([10639,11008,11535,10387],0); -ELEMENTS[58563] = Fluid3D([11008,11535,10387,11880],0); -ELEMENTS[58564] = Fluid3D([11535,10639,10387,10603],0); -ELEMENTS[58565] = Fluid3D([10639,11008,10387,9693],0); -ELEMENTS[58566] = Fluid3D([11008,11535,11880,11646],0); -ELEMENTS[58567] = Fluid3D([11646,10639,11535,11858],0); -ELEMENTS[58568] = Fluid3D([11535,11646,11858,12691],0); -ELEMENTS[58569] = Fluid3D([11535,10387,11880,11360],0); -ELEMENTS[58570] = Fluid3D([11880,11535,11360,11858],0); -ELEMENTS[58571] = Fluid3D([11535,11360,11858,10603],0); -ELEMENTS[58572] = Fluid3D([11535,10387,11360,10603],0); -ELEMENTS[58573] = Fluid3D([11880,11535,11858,12512],0); -ELEMENTS[58574] = Fluid3D([11880,11535,12512,11646],0); -ELEMENTS[58575] = Fluid3D([11535,11858,12512,12691],0); -ELEMENTS[58576] = Fluid3D([10639,11535,11858,10603],0); -ELEMENTS[58577] = Fluid3D([5929,6265,5894,5512],0); -ELEMENTS[58578] = Fluid3D([3673,4078,3752,4190],0); -ELEMENTS[58579] = Fluid3D([3673,4078,4190,4023],0); -ELEMENTS[58580] = Fluid3D([4078,3752,4190,4173],0); -ELEMENTS[58581] = Fluid3D([4078,4190,4023,4469],0); -ELEMENTS[58582] = Fluid3D([4190,4078,4173,4562],0); -ELEMENTS[58583] = Fluid3D([16127,16398,16480,15873],0); -ELEMENTS[58584] = Fluid3D([5093,5017,5626,5261],0); -ELEMENTS[58585] = Fluid3D([7149,7306,8046,7958],0); -ELEMENTS[58586] = Fluid3D([7149,7306,7958,7072],0); -ELEMENTS[58587] = Fluid3D([4777,4715,5046,4199],0); -ELEMENTS[58588] = Fluid3D([9656,10643,10227,10383],0); -ELEMENTS[58589] = Fluid3D([11999,12343,11375,12684],0); -ELEMENTS[58590] = Fluid3D([3773,3614,4041,3852],0); -ELEMENTS[58591] = Fluid3D([3614,4041,3852,3888],0); -ELEMENTS[58592] = Fluid3D([3852,3614,3888,3476],0); -ELEMENTS[58593] = Fluid3D([3852,3614,3476,3219],0); -ELEMENTS[58594] = Fluid3D([3773,3614,3852,3608],0); -ELEMENTS[58595] = Fluid3D([3614,3852,3608,3219],0); -ELEMENTS[58596] = Fluid3D([14542,14993,14668,14335],0); -ELEMENTS[58597] = Fluid3D([8288,9105,8149,8520],0); -ELEMENTS[58598] = Fluid3D([9105,8149,8520,8989],0); -ELEMENTS[58599] = Fluid3D([8149,8520,8989,8046],0); -ELEMENTS[58600] = Fluid3D([14654,15141,15115,15715],0); -ELEMENTS[58601] = Fluid3D([4031,4147,4496,4552],0); -ELEMENTS[58602] = Fluid3D([18439,18304,18394,18290],0); -ELEMENTS[58603] = Fluid3D([18439,18304,18290,18353],0); -ELEMENTS[58604] = Fluid3D([18394,18439,18290,18517],0); -ELEMENTS[58605] = Fluid3D([18304,18394,18290,18242],0); -ELEMENTS[58606] = Fluid3D([2142,2060,1931,2080],0); -ELEMENTS[58607] = Fluid3D([10661,11468,11599,11960],0); -ELEMENTS[58608] = Fluid3D([9637,9875,10712,10068],0); -ELEMENTS[58609] = Fluid3D([9858,10788,10604,10099],0); -ELEMENTS[58610] = Fluid3D([10788,10604,10099,11726],0); -ELEMENTS[58611] = Fluid3D([3468,3713,3312,3776],0); -ELEMENTS[58612] = Fluid3D([18404,18369,18255,18222],0); -ELEMENTS[58613] = Fluid3D([15967,16153,15764,15334],0); -ELEMENTS[58614] = Fluid3D([18009,17790,18016,17850],0); -ELEMENTS[58615] = Fluid3D([18016,18009,17850,18191],0); -ELEMENTS[58616] = Fluid3D([9759,8967,9814,8778],0); -ELEMENTS[58617] = Fluid3D([2254,2357,2498,2518],0); -ELEMENTS[58618] = Fluid3D([12949,13755,13279,13866],0); -ELEMENTS[58619] = Fluid3D([15026,14735,14174,14396],0); -ELEMENTS[58620] = Fluid3D([7529,7249,6714,7740],0); -ELEMENTS[58621] = Fluid3D([13950,14212,14765,14145],0); -ELEMENTS[58622] = Fluid3D([11011,10003,10664,10918],0); -ELEMENTS[58623] = Fluid3D([11011,10003,10918,10803],0); -ELEMENTS[58624] = Fluid3D([15784,15925,16390,16065],0); -ELEMENTS[58625] = Fluid3D([2245,2066,2229,2291],0); -ELEMENTS[58626] = Fluid3D([15912,15817,15512,15584],0); -ELEMENTS[58627] = Fluid3D([15912,15817,15584,16196],0); -ELEMENTS[58628] = Fluid3D([15584,15912,16196,15915],0); -ELEMENTS[58629] = Fluid3D([16196,15584,15915,15817],0); -ELEMENTS[58630] = Fluid3D([15912,16196,15915,16296],0); -ELEMENTS[58631] = Fluid3D([16196,15915,16296,16550],0); -ELEMENTS[58632] = Fluid3D([16196,15915,16550,16462],0); -ELEMENTS[58633] = Fluid3D([16196,15915,16462,16118],0); -ELEMENTS[58634] = Fluid3D([15915,16196,15817,16118],0); -ELEMENTS[58635] = Fluid3D([15584,15912,15915,16296],0); -ELEMENTS[58636] = Fluid3D([15647,15579,15900,15653],0); -ELEMENTS[58637] = Fluid3D([5445,4908,5027,4871],0); -ELEMENTS[58638] = Fluid3D([4908,5027,4871,4498],0); -ELEMENTS[58639] = Fluid3D([5027,5445,4871,5598],0); -ELEMENTS[58640] = Fluid3D([5445,4908,4871,5334],0); -ELEMENTS[58641] = Fluid3D([12139,11190,11418,11862],0); -ELEMENTS[58642] = Fluid3D([3815,3589,3407,3723],0); -ELEMENTS[58643] = Fluid3D([3589,3407,3723,3192],0); -ELEMENTS[58644] = Fluid3D([13991,14073,14750,13628],0); -ELEMENTS[58645] = Fluid3D([4077,4210,3686,3991],0); -ELEMENTS[58646] = Fluid3D([4210,3686,3991,3813],0); -ELEMENTS[58647] = Fluid3D([3686,4077,3991,3595],0); -ELEMENTS[58648] = Fluid3D([4077,4210,3991,4644],0); -ELEMENTS[58649] = Fluid3D([18360,18306,18190,18004],0); -ELEMENTS[58650] = Fluid3D([2300,2398,2464,2174],0); -ELEMENTS[58651] = Fluid3D([10871,10227,11247,10383],0); -ELEMENTS[58652] = Fluid3D([10227,11247,10383,10643],0); -ELEMENTS[58653] = Fluid3D([11649,12722,12244,12336],0); -ELEMENTS[58654] = Fluid3D([12722,12244,12336,13278],0); -ELEMENTS[58655] = Fluid3D([12244,11649,12336,11128],0); -ELEMENTS[58656] = Fluid3D([11649,12722,12336,11925],0); -ELEMENTS[58657] = Fluid3D([7035,7838,7014,7317],0); -ELEMENTS[58658] = Fluid3D([7838,7014,7317,7819],0); -ELEMENTS[58659] = Fluid3D([16993,16653,16823,16255],0); -ELEMENTS[58660] = Fluid3D([13165,12968,13486,12165],0); -ELEMENTS[58661] = Fluid3D([6038,6591,6815,6617],0); -ELEMENTS[58662] = Fluid3D([8988,9127,9871,10271],0); -ELEMENTS[58663] = Fluid3D([5019,4524,4430,4949],0); -ELEMENTS[58664] = Fluid3D([4430,5019,4949,4929],0); -ELEMENTS[58665] = Fluid3D([5019,4524,4949,5139],0); -ELEMENTS[58666] = Fluid3D([5019,4949,4929,5562],0); -ELEMENTS[58667] = Fluid3D([4949,5019,5139,5695],0); -ELEMENTS[58668] = Fluid3D([5019,4949,5562,5695],0); -ELEMENTS[58669] = Fluid3D([2108,2314,2212,2237],0); -ELEMENTS[58670] = Fluid3D([2108,2314,2237,2204],0); -ELEMENTS[58671] = Fluid3D([2237,2108,2204,2021],0); -ELEMENTS[58672] = Fluid3D([2237,2108,2021,1941],0); -ELEMENTS[58673] = Fluid3D([16716,17043,16906,16382],0); -ELEMENTS[58674] = Fluid3D([11161,11587,10581,12044],0); -ELEMENTS[58675] = Fluid3D([9396,9110,9477,10104],0); -ELEMENTS[58676] = Fluid3D([15372,15227,15646,15113],0); -ELEMENTS[58677] = Fluid3D([15227,15646,15113,15529],0); -ELEMENTS[58678] = Fluid3D([15113,15227,15529,14627],0); -ELEMENTS[58679] = Fluid3D([15372,15227,15113,14419],0); -ELEMENTS[58680] = Fluid3D([2273,2423,2529,2672],0); -ELEMENTS[58681] = Fluid3D([9314,8631,8442,9447],0); -ELEMENTS[58682] = Fluid3D([15070,15264,14766,15597],0); -ELEMENTS[58683] = Fluid3D([15070,15264,15597,15920],0); -ELEMENTS[58684] = Fluid3D([5529,6118,6022,5977],0); -ELEMENTS[58685] = Fluid3D([6022,5529,5977,5433],0); -ELEMENTS[58686] = Fluid3D([5977,6022,5433,5948],0); -ELEMENTS[58687] = Fluid3D([5529,5977,5433,5282],0); -ELEMENTS[58688] = Fluid3D([6118,6022,5977,7146],0); -ELEMENTS[58689] = Fluid3D([5529,6118,5977,6255],0); -ELEMENTS[58690] = Fluid3D([10712,11779,11557,10960],0); -ELEMENTS[58691] = Fluid3D([15552,15601,15940,15025],0); -ELEMENTS[58692] = Fluid3D([15552,15601,15025,15207],0); -ELEMENTS[58693] = Fluid3D([3716,3610,3328,3781],0); -ELEMENTS[58694] = Fluid3D([17472,17197,17235,16818],0); -ELEMENTS[58695] = Fluid3D([16568,17093,16937,16927],0); -ELEMENTS[58696] = Fluid3D([16478,16111,16329,15859],0); -ELEMENTS[58697] = Fluid3D([16478,16111,15859,16291],0); -ELEMENTS[58698] = Fluid3D([3886,4122,4357,4308],0); -ELEMENTS[58699] = Fluid3D([4357,3886,4308,4092],0); -ELEMENTS[58700] = Fluid3D([3154,2855,3040,3193],0); -ELEMENTS[58701] = Fluid3D([3154,2855,3193,3012],0); -ELEMENTS[58702] = Fluid3D([3154,2855,3012,2852],0); -ELEMENTS[58703] = Fluid3D([1785,1677,1713,1786],0); -ELEMENTS[58704] = Fluid3D([3656,3464,3886,3848],0); -ELEMENTS[58705] = Fluid3D([16681,16628,16953,16186],0); -ELEMENTS[58706] = Fluid3D([16813,16884,17115,16637],0); -ELEMENTS[58707] = Fluid3D([16884,17115,16637,17196],0); -ELEMENTS[58708] = Fluid3D([16569,17042,16952,16690],0); -ELEMENTS[58709] = Fluid3D([5562,4929,5454,5329],0); -ELEMENTS[58710] = Fluid3D([17972,18078,18214,18266],0); -ELEMENTS[58711] = Fluid3D([18214,17972,18266,18080],0); -ELEMENTS[58712] = Fluid3D([18214,17972,18080,18030],0); -ELEMENTS[58713] = Fluid3D([18214,17972,18030,18175],0); -ELEMENTS[58714] = Fluid3D([17972,18080,18030,17791],0); -ELEMENTS[58715] = Fluid3D([5008,5594,5386,5857],0); -ELEMENTS[58716] = Fluid3D([11137,10827,10136,10326],0); -ELEMENTS[58717] = Fluid3D([10482,11362,10284,10868],0); -ELEMENTS[58718] = Fluid3D([13977,14473,14197,13602],0); -ELEMENTS[58719] = Fluid3D([15521,15361,15084,14751],0); -ELEMENTS[58720] = Fluid3D([15361,15084,14751,14906],0); -ELEMENTS[58721] = Fluid3D([15084,15521,14751,15283],0); -ELEMENTS[58722] = Fluid3D([6094,5674,6134,6653],0); -ELEMENTS[58723] = Fluid3D([8015,7228,7912,7923],0); -ELEMENTS[58724] = Fluid3D([7228,7912,7923,7130],0); -ELEMENTS[58725] = Fluid3D([7912,7923,7130,7823],0); -ELEMENTS[58726] = Fluid3D([7912,8015,7923,8729],0); -ELEMENTS[58727] = Fluid3D([7912,7923,7823,8720],0); -ELEMENTS[58728] = Fluid3D([7912,7923,8720,8729],0); -ELEMENTS[58729] = Fluid3D([7923,7228,7130,7233],0); -ELEMENTS[58730] = Fluid3D([7923,7228,7233,8015],0); -ELEMENTS[58731] = Fluid3D([18373,18467,18497,18355],0); -ELEMENTS[58732] = Fluid3D([9865,9355,10524,9906],0); -ELEMENTS[58733] = Fluid3D([10314,11069,9952,10058],0); -ELEMENTS[58734] = Fluid3D([2211,2447,2312,2516],0); -ELEMENTS[58735] = Fluid3D([2211,2447,2516,2342],0); -ELEMENTS[58736] = Fluid3D([2447,2312,2516,2561],0); -ELEMENTS[58737] = Fluid3D([2447,2516,2342,2590],0); -ELEMENTS[58738] = Fluid3D([3831,3427,3894,3401],0); -ELEMENTS[58739] = Fluid3D([3831,3427,3401,3383],0); -ELEMENTS[58740] = Fluid3D([3427,3401,3383,3010],0); -ELEMENTS[58741] = Fluid3D([3401,3831,3383,3655],0); -ELEMENTS[58742] = Fluid3D([3427,3401,3010,2889],0); -ELEMENTS[58743] = Fluid3D([3427,3894,3401,3489],0); -ELEMENTS[58744] = Fluid3D([3401,3427,3489,2889],0); -ELEMENTS[58745] = Fluid3D([3427,3894,3489,3490],0); -ELEMENTS[58746] = Fluid3D([13950,14519,13706,13913],0); -ELEMENTS[58747] = Fluid3D([18372,18227,18245,18196],0); -ELEMENTS[58748] = Fluid3D([17145,16993,16823,16693],0); -ELEMENTS[58749] = Fluid3D([10427,11357,11266,10927],0); -ELEMENTS[58750] = Fluid3D([11266,10427,10927,10354],0); -ELEMENTS[58751] = Fluid3D([10427,10927,10354,9530],0); -ELEMENTS[58752] = Fluid3D([10427,11357,10927,10536],0); -ELEMENTS[58753] = Fluid3D([10427,10927,9530,10132],0); -ELEMENTS[58754] = Fluid3D([10427,10927,10132,10536],0); -ELEMENTS[58755] = Fluid3D([15981,16383,16235,15760],0); -ELEMENTS[58756] = Fluid3D([17585,17486,17757,17274],0); -ELEMENTS[58757] = Fluid3D([17202,17072,16881,16747],0); -ELEMENTS[58758] = Fluid3D([17072,16881,16747,16749],0); -ELEMENTS[58759] = Fluid3D([16881,17202,16747,16700],0); -ELEMENTS[58760] = Fluid3D([17202,17072,16747,16819],0); -ELEMENTS[58761] = Fluid3D([16747,17202,16819,16700],0); -ELEMENTS[58762] = Fluid3D([16819,16747,16700,16303],0); -ELEMENTS[58763] = Fluid3D([16819,16747,16303,16948],0); -ELEMENTS[58764] = Fluid3D([16747,16700,16303,16881],0); -ELEMENTS[58765] = Fluid3D([17072,16747,16819,16948],0); -ELEMENTS[58766] = Fluid3D([2312,2431,2204,2463],0); -ELEMENTS[58767] = Fluid3D([15752,15447,15059,15132],0); -ELEMENTS[58768] = Fluid3D([18515,18592,18581,18514],0); -ELEMENTS[58769] = Fluid3D([5153,5439,5773,5841],0); -ELEMENTS[58770] = Fluid3D([12498,12946,13420,12457],0); -ELEMENTS[58771] = Fluid3D([7890,7958,8805,7983],0); -ELEMENTS[58772] = Fluid3D([7352,8117,7747,7280],0); -ELEMENTS[58773] = Fluid3D([7352,8117,7280,7722],0); -ELEMENTS[58774] = Fluid3D([10680,10807,11131,12014],0); -ELEMENTS[58775] = Fluid3D([7467,7090,6885,7775],0); -ELEMENTS[58776] = Fluid3D([12925,12760,12033,12311],0); -ELEMENTS[58777] = Fluid3D([10339,9367,10031,10969],0); -ELEMENTS[58778] = Fluid3D([2550,2743,2350,2701],0); -ELEMENTS[58779] = Fluid3D([2264,2072,2207,2350],0); -ELEMENTS[58780] = Fluid3D([13455,13524,13039,12680],0); -ELEMENTS[58781] = Fluid3D([13524,13039,12680,12416],0); -ELEMENTS[58782] = Fluid3D([13455,13524,12680,13908],0); -ELEMENTS[58783] = Fluid3D([13039,13455,12680,12983],0); -ELEMENTS[58784] = Fluid3D([14450,14385,13980,13467],0); -ELEMENTS[58785] = Fluid3D([18613,18516,18542,18518],0); -ELEMENTS[58786] = Fluid3D([17639,17817,17561,17480],0); -ELEMENTS[58787] = Fluid3D([17817,17561,17480,17742],0); -ELEMENTS[58788] = Fluid3D([12847,13832,13505,13629],0); -ELEMENTS[58789] = Fluid3D([2784,2611,2917,3072],0); -ELEMENTS[58790] = Fluid3D([2611,2917,3072,2756],0); -ELEMENTS[58791] = Fluid3D([2917,3072,2756,3078],0); -ELEMENTS[58792] = Fluid3D([2917,3072,3078,3269],0); -ELEMENTS[58793] = Fluid3D([2917,3072,3269,3109],0); -ELEMENTS[58794] = Fluid3D([2917,3072,3109,2784],0); -ELEMENTS[58795] = Fluid3D([18343,18259,18410,18096],0); -ELEMENTS[58796] = Fluid3D([15920,16495,16224,16076],0); -ELEMENTS[58797] = Fluid3D([15607,15440,15185,14720],0); -ELEMENTS[58798] = Fluid3D([15185,15607,14720,15375],0); -ELEMENTS[58799] = Fluid3D([14720,15185,15375,14922],0); -ELEMENTS[58800] = Fluid3D([16962,17245,16791,16920],0); -ELEMENTS[58801] = Fluid3D([2025,1907,2062,2170],0); -ELEMENTS[58802] = Fluid3D([2062,2025,2170,2203],0); -ELEMENTS[58803] = Fluid3D([16575,16746,17096,16892],0); -ELEMENTS[58804] = Fluid3D([16746,17096,16892,17246],0); -ELEMENTS[58805] = Fluid3D([17347,17562,17284,17132],0); -ELEMENTS[58806] = Fluid3D([17284,17347,17132,16942],0); -ELEMENTS[58807] = Fluid3D([17132,17284,16942,16872],0); -ELEMENTS[58808] = Fluid3D([16942,17132,16872,16692],0); -ELEMENTS[58809] = Fluid3D([16942,17132,16692,17347],0); -ELEMENTS[58810] = Fluid3D([17132,17284,16872,17231],0); -ELEMENTS[58811] = Fluid3D([16872,17132,17231,17171],0); -ELEMENTS[58812] = Fluid3D([17132,17231,17171,17562],0); -ELEMENTS[58813] = Fluid3D([17171,17132,17562,17347],0); -ELEMENTS[58814] = Fluid3D([17284,17347,16942,17047],0); -ELEMENTS[58815] = Fluid3D([17347,16942,17047,17115],0); -ELEMENTS[58816] = Fluid3D([16942,17284,17047,16817],0); -ELEMENTS[58817] = Fluid3D([17047,16942,16817,16673],0); -ELEMENTS[58818] = Fluid3D([17047,16942,16673,17115],0); -ELEMENTS[58819] = Fluid3D([16942,16817,16673,16872],0); -ELEMENTS[58820] = Fluid3D([16942,16817,16872,17284],0); -ELEMENTS[58821] = Fluid3D([16817,16872,17284,17235],0); -ELEMENTS[58822] = Fluid3D([17562,17284,17132,17231],0); -ELEMENTS[58823] = Fluid3D([16673,16942,16872,16692],0); -ELEMENTS[58824] = Fluid3D([16673,16942,16692,17115],0); -ELEMENTS[58825] = Fluid3D([16817,17047,16673,16733],0); -ELEMENTS[58826] = Fluid3D([17047,16673,16733,16813],0); -ELEMENTS[58827] = Fluid3D([16872,17132,17171,16692],0); -ELEMENTS[58828] = Fluid3D([9280,8385,8709,9170],0); -ELEMENTS[58829] = Fluid3D([8709,9280,9170,9925],0); -ELEMENTS[58830] = Fluid3D([9280,9170,9925,8979],0); -ELEMENTS[58831] = Fluid3D([9280,8385,9170,8979],0); -ELEMENTS[58832] = Fluid3D([8385,8709,9170,8734],0); -ELEMENTS[58833] = Fluid3D([9170,8385,8734,9108],0); -ELEMENTS[58834] = Fluid3D([8734,9170,9108,9853],0); -ELEMENTS[58835] = Fluid3D([8709,9170,8734,9054],0); -ELEMENTS[58836] = Fluid3D([9170,8734,9054,9853],0); -ELEMENTS[58837] = Fluid3D([12604,13497,13283,12800],0); -ELEMENTS[58838] = Fluid3D([13283,12604,12800,12399],0); -ELEMENTS[58839] = Fluid3D([12604,13497,12800,12208],0); -ELEMENTS[58840] = Fluid3D([12800,12604,12208,11619],0); -ELEMENTS[58841] = Fluid3D([12208,12800,11619,11821],0); -ELEMENTS[58842] = Fluid3D([13497,13283,12800,14116],0); -ELEMENTS[58843] = Fluid3D([13497,12800,12208,12929],0); -ELEMENTS[58844] = Fluid3D([12800,12208,12929,11821],0); -ELEMENTS[58845] = Fluid3D([13497,12800,12929,13571],0); -ELEMENTS[58846] = Fluid3D([12800,12929,13571,12610],0); -ELEMENTS[58847] = Fluid3D([12800,12929,12610,11821],0); -ELEMENTS[58848] = Fluid3D([13571,12800,12610,14116],0); -ELEMENTS[58849] = Fluid3D([13497,12800,13571,14116],0); -ELEMENTS[58850] = Fluid3D([13571,13497,14116,14308],0); -ELEMENTS[58851] = Fluid3D([14116,13571,14308,14893],0); -ELEMENTS[58852] = Fluid3D([12610,12800,11821,11619],0); -ELEMENTS[58853] = Fluid3D([12610,12800,11619,12399],0); -ELEMENTS[58854] = Fluid3D([7881,7330,7537,6680],0); -ELEMENTS[58855] = Fluid3D([14284,14644,14175,13925],0); -ELEMENTS[58856] = Fluid3D([14284,14644,13925,14768],0); -ELEMENTS[58857] = Fluid3D([13925,14284,14768,14410],0); -ELEMENTS[58858] = Fluid3D([12422,12807,12601,11650],0); -ELEMENTS[58859] = Fluid3D([5920,6573,6420,6029],0); -ELEMENTS[58860] = Fluid3D([2403,2460,2365,2237],0); -ELEMENTS[58861] = Fluid3D([5467,5324,5918,6102],0); -ELEMENTS[58862] = Fluid3D([2618,2380,2401,2365],0); -ELEMENTS[58863] = Fluid3D([2618,2380,2365,2673],0); -ELEMENTS[58864] = Fluid3D([18390,18468,18337,18191],0); -ELEMENTS[58865] = Fluid3D([16031,15896,15414,15633],0); -ELEMENTS[58866] = Fluid3D([14371,14296,13660,14149],0); -ELEMENTS[58867] = Fluid3D([14371,14296,14149,14665],0); -ELEMENTS[58868] = Fluid3D([14296,14149,14665,13791],0); -ELEMENTS[58869] = Fluid3D([14296,14149,13791,13660],0); -ELEMENTS[58870] = Fluid3D([13660,14371,14149,14343],0); -ELEMENTS[58871] = Fluid3D([14371,14149,14343,14665],0); -ELEMENTS[58872] = Fluid3D([14338,14275,15053,14717],0); -ELEMENTS[58873] = Fluid3D([18073,18209,18027,17920],0); -ELEMENTS[58874] = Fluid3D([4083,3888,3476,4081],0); -ELEMENTS[58875] = Fluid3D([5081,5025,4488,5028],0); -ELEMENTS[58876] = Fluid3D([5081,5025,5028,5651],0); -ELEMENTS[58877] = Fluid3D([5025,5028,5651,5608],0); -ELEMENTS[58878] = Fluid3D([5025,4488,5028,4377],0); -ELEMENTS[58879] = Fluid3D([4488,5028,4377,5081],0); -ELEMENTS[58880] = Fluid3D([6118,6823,6693,7146],0); -ELEMENTS[58881] = Fluid3D([7912,7823,8636,8720],0); -ELEMENTS[58882] = Fluid3D([3230,3214,3430,2888],0); -ELEMENTS[58883] = Fluid3D([8619,7755,8595,7955],0); -ELEMENTS[58884] = Fluid3D([17584,17193,17272,16987],0); -ELEMENTS[58885] = Fluid3D([18300,18435,18404,18292],0); -ELEMENTS[58886] = Fluid3D([12210,12457,12946,12498],0); -ELEMENTS[58887] = Fluid3D([6805,7188,6978,7867],0); -ELEMENTS[58888] = Fluid3D([8923,9441,8514,9334],0); -ELEMENTS[58889] = Fluid3D([4269,4104,3916,4466],0); -ELEMENTS[58890] = Fluid3D([4104,3916,4466,4202],0); -ELEMENTS[58891] = Fluid3D([4269,4104,4466,4643],0); -ELEMENTS[58892] = Fluid3D([17173,17292,17598,17691],0); -ELEMENTS[58893] = Fluid3D([7081,7641,7413,7368],0); -ELEMENTS[58894] = Fluid3D([12638,12523,11740,11345],0); -ELEMENTS[58895] = Fluid3D([7773,8631,7998,8596],0); -ELEMENTS[58896] = Fluid3D([18156,17921,17934,17789],0); -ELEMENTS[58897] = Fluid3D([16346,16300,15982,15480],0); -ELEMENTS[58898] = Fluid3D([4751,4640,4263,4991],0); -ELEMENTS[58899] = Fluid3D([18674,18683,18648,18663],0); -ELEMENTS[58900] = Fluid3D([10000,9516,8933,9353],0); -ELEMENTS[58901] = Fluid3D([8288,8447,9244,8735],0); -ELEMENTS[58902] = Fluid3D([3513,3130,3371,3363],0); -ELEMENTS[58903] = Fluid3D([3130,3371,3363,3002],0); -ELEMENTS[58904] = Fluid3D([3371,3363,3002,3219],0); -ELEMENTS[58905] = Fluid3D([3363,3130,3002,2806],0); -ELEMENTS[58906] = Fluid3D([14146,14646,14386,13694],0); -ELEMENTS[58907] = Fluid3D([8285,7506,7592,7302],0); -ELEMENTS[58908] = Fluid3D([1575,1593,1660,1659],0); -ELEMENTS[58909] = Fluid3D([15934,15698,15285,15030],0); -ELEMENTS[58910] = Fluid3D([2497,2664,2400,2718],0); -ELEMENTS[58911] = Fluid3D([16966,16630,16749,16201],0); -ELEMENTS[58912] = Fluid3D([6558,5869,6551,6414],0); -ELEMENTS[58913] = Fluid3D([12117,11803,11137,11133],0); -ELEMENTS[58914] = Fluid3D([5439,6073,5773,6294],0); -ELEMENTS[58915] = Fluid3D([15941,15777,15521,15441],0); -ELEMENTS[58916] = Fluid3D([12679,11799,12765,12276],0); -ELEMENTS[58917] = Fluid3D([12679,11799,12276,12162],0); -ELEMENTS[58918] = Fluid3D([12276,12679,12162,13441],0); -ELEMENTS[58919] = Fluid3D([11799,12276,12162,11392],0); -ELEMENTS[58920] = Fluid3D([11799,12765,12276,11851],0); -ELEMENTS[58921] = Fluid3D([12276,11799,11851,11392],0); -ELEMENTS[58922] = Fluid3D([11851,12276,11392,12696],0); -ELEMENTS[58923] = Fluid3D([12765,12679,12276,12746],0); -ELEMENTS[58924] = Fluid3D([12276,12765,12746,11851],0); -ELEMENTS[58925] = Fluid3D([12746,12276,11851,12696],0); -ELEMENTS[58926] = Fluid3D([12746,12276,12696,13002],0); -ELEMENTS[58927] = Fluid3D([12746,12276,13002,12679],0); -ELEMENTS[58928] = Fluid3D([12696,12746,13002,13316],0); -ELEMENTS[58929] = Fluid3D([12746,13002,13316,12679],0); -ELEMENTS[58930] = Fluid3D([12276,13002,12679,13441],0); -ELEMENTS[58931] = Fluid3D([12276,13002,13441,12696],0); -ELEMENTS[58932] = Fluid3D([13002,13441,12696,13316],0); -ELEMENTS[58933] = Fluid3D([13002,13441,13316,13501],0); -ELEMENTS[58934] = Fluid3D([13316,13002,13501,12679],0); -ELEMENTS[58935] = Fluid3D([13002,12679,13441,13501],0); -ELEMENTS[58936] = Fluid3D([12968,12774,13290,12083],0); -ELEMENTS[58937] = Fluid3D([12968,12774,12083,12452],0); -ELEMENTS[58938] = Fluid3D([1621,1563,1553,1641],0); -ELEMENTS[58939] = Fluid3D([6437,6226,5795,6342],0); -ELEMENTS[58940] = Fluid3D([5795,6437,6342,5989],0); -ELEMENTS[58941] = Fluid3D([6226,5795,6342,6442],0); -ELEMENTS[58942] = Fluid3D([6342,6226,6442,7285],0); -ELEMENTS[58943] = Fluid3D([6437,6226,6342,7285],0); -ELEMENTS[58944] = Fluid3D([11513,12375,12328,12106],0); -ELEMENTS[58945] = Fluid3D([12375,12328,12106,13151],0); -ELEMENTS[58946] = Fluid3D([12328,12106,13151,12835],0); -ELEMENTS[58947] = Fluid3D([12106,13151,12835,12521],0); -ELEMENTS[58948] = Fluid3D([5424,5356,5930,5775],0); -ELEMENTS[58949] = Fluid3D([18080,18266,18136,17874],0); -ELEMENTS[58950] = Fluid3D([18645,18626,18594,18572],0); -ELEMENTS[58951] = Fluid3D([5432,5656,5299,5220],0); -ELEMENTS[58952] = Fluid3D([17871,18071,18059,17770],0); -ELEMENTS[58953] = Fluid3D([5884,5322,5984,5676],0); -ELEMENTS[58954] = Fluid3D([15995,15820,16220,15191],0); -ELEMENTS[58955] = Fluid3D([17702,17547,17756,17918],0); -ELEMENTS[58956] = Fluid3D([17756,17702,17918,17935],0); -ELEMENTS[58957] = Fluid3D([17756,17702,17935,17485],0); -ELEMENTS[58958] = Fluid3D([17702,17918,17935,17954],0); -ELEMENTS[58959] = Fluid3D([17702,17935,17485,17872],0); -ELEMENTS[58960] = Fluid3D([9617,8765,8860,9470],0); -ELEMENTS[58961] = Fluid3D([7561,7361,6769,6872],0); -ELEMENTS[58962] = Fluid3D([13632,14053,13929,13251],0); -ELEMENTS[58963] = Fluid3D([9120,9061,8132,9117],0); -ELEMENTS[58964] = Fluid3D([17606,17763,17498,17554],0); -ELEMENTS[58965] = Fluid3D([17606,17763,17554,17866],0); -ELEMENTS[58966] = Fluid3D([17763,17554,17866,17860],0); -ELEMENTS[58967] = Fluid3D([6285,5660,5956,6566],0); -ELEMENTS[58968] = Fluid3D([5956,6285,6566,6670],0); -ELEMENTS[58969] = Fluid3D([6285,5660,6566,5981],0); -ELEMENTS[58970] = Fluid3D([6285,6566,6670,7082],0); -ELEMENTS[58971] = Fluid3D([2748,2413,2644,2638],0); -ELEMENTS[58972] = Fluid3D([5801,5457,5190,5452],0); -ELEMENTS[58973] = Fluid3D([17695,17926,17761,17449],0); -ELEMENTS[58974] = Fluid3D([7958,8046,8876,8934],0); -ELEMENTS[58975] = Fluid3D([16532,16420,16762,16160],0); -ELEMENTS[58976] = Fluid3D([2789,2878,2586,2871],0); -ELEMENTS[58977] = Fluid3D([2878,2586,2871,2692],0); -ELEMENTS[58978] = Fluid3D([2586,2789,2871,2504],0); -ELEMENTS[58979] = Fluid3D([13580,13073,13242,12511],0); -ELEMENTS[58980] = Fluid3D([8757,7930,7508,8180],0); -ELEMENTS[58981] = Fluid3D([4891,4496,5032,4887],0); -ELEMENTS[58982] = Fluid3D([7861,8156,7314,8105],0); -ELEMENTS[58983] = Fluid3D([7314,7861,8105,7051],0); -ELEMENTS[58984] = Fluid3D([7861,8105,7051,7624],0); -ELEMENTS[58985] = Fluid3D([18325,18408,18457,18270],0); -ELEMENTS[58986] = Fluid3D([15067,14256,14433,14602],0); -ELEMENTS[58987] = Fluid3D([14433,15067,14602,15162],0); -ELEMENTS[58988] = Fluid3D([15067,14602,15162,15344],0); -ELEMENTS[58989] = Fluid3D([14256,14433,14602,13555],0); -ELEMENTS[58990] = Fluid3D([15067,14256,14602,14923],0); -ELEMENTS[58991] = Fluid3D([14602,15162,15344,15188],0); -ELEMENTS[58992] = Fluid3D([14602,14433,15162,14489],0); -ELEMENTS[58993] = Fluid3D([15162,14602,14489,15188],0); -ELEMENTS[58994] = Fluid3D([11960,12461,12094,10795],0); -ELEMENTS[58995] = Fluid3D([17569,17447,17802,17842],0); -ELEMENTS[58996] = Fluid3D([2772,3094,2969,3073],0); -ELEMENTS[58997] = Fluid3D([13286,14217,13972,13408],0); -ELEMENTS[58998] = Fluid3D([16027,16181,16392,15891],0); -ELEMENTS[58999] = Fluid3D([10585,10598,11476,10512],0); -ELEMENTS[59000] = Fluid3D([10585,10598,10512,9727],0); -ELEMENTS[59001] = Fluid3D([11476,10585,10512,10797],0); -ELEMENTS[59002] = Fluid3D([10598,11476,10512,11513],0); -ELEMENTS[59003] = Fluid3D([18505,18469,18382,18374],0); -ELEMENTS[59004] = Fluid3D([2226,1992,2025,2047],0); -ELEMENTS[59005] = Fluid3D([2054,2248,2182,2233],0); -ELEMENTS[59006] = Fluid3D([17266,16974,17064,16500],0); -ELEMENTS[59007] = Fluid3D([3384,3326,3778,3491],0); -ELEMENTS[59008] = Fluid3D([3778,3384,3491,3897],0); -ELEMENTS[59009] = Fluid3D([3384,3326,3491,2974],0); -ELEMENTS[59010] = Fluid3D([3326,3778,3491,3562],0); -ELEMENTS[59011] = Fluid3D([3491,3326,3562,3253],0); -ELEMENTS[59012] = Fluid3D([3562,3491,3253,3765],0); -ELEMENTS[59013] = Fluid3D([3562,3491,3765,3778],0); -ELEMENTS[59014] = Fluid3D([3491,3765,3778,3897],0); -ELEMENTS[59015] = Fluid3D([3491,3765,3897,3458],0); -ELEMENTS[59016] = Fluid3D([3491,3253,3765,3458],0); -ELEMENTS[59017] = Fluid3D([3765,3778,3897,4150],0); -ELEMENTS[59018] = Fluid3D([3897,3765,4150,3958],0); -ELEMENTS[59019] = Fluid3D([3897,3765,3958,3458],0); -ELEMENTS[59020] = Fluid3D([9390,9229,10337,9748],0); -ELEMENTS[59021] = Fluid3D([7000,6489,7309,7403],0); -ELEMENTS[59022] = Fluid3D([5801,6162,6465,6824],0); -ELEMENTS[59023] = Fluid3D([4359,4952,4639,5013],0); -ELEMENTS[59024] = Fluid3D([1829,1939,1964,1976],0); -ELEMENTS[59025] = Fluid3D([1964,1829,1976,1849],0); -ELEMENTS[59026] = Fluid3D([1829,1939,1976,1809],0); -ELEMENTS[59027] = Fluid3D([14449,14376,14833,13606],0); -ELEMENTS[59028] = Fluid3D([9047,8817,8169,9070],0); -ELEMENTS[59029] = Fluid3D([8169,9047,9070,8416],0); -ELEMENTS[59030] = Fluid3D([5705,6293,6205,6065],0); -ELEMENTS[59031] = Fluid3D([6293,6205,6065,6922],0); -ELEMENTS[59032] = Fluid3D([17953,17915,18113,17715],0); -ELEMENTS[59033] = Fluid3D([3306,3459,3090,3649],0); -ELEMENTS[59034] = Fluid3D([6526,6689,5719,5978],0); -ELEMENTS[59035] = Fluid3D([5719,6526,5978,6393],0); -ELEMENTS[59036] = Fluid3D([4776,4734,4266,3965],0); -ELEMENTS[59037] = Fluid3D([14862,15195,15621,15118],0); -ELEMENTS[59038] = Fluid3D([15621,14862,15118,15328],0); -ELEMENTS[59039] = Fluid3D([14862,15195,15118,14331],0); -ELEMENTS[59040] = Fluid3D([14862,15118,15328,14562],0); -ELEMENTS[59041] = Fluid3D([15195,15621,15118,15142],0); -ELEMENTS[59042] = Fluid3D([15118,15195,15142,14331],0); -ELEMENTS[59043] = Fluid3D([18147,17954,17985,17699],0); -ELEMENTS[59044] = Fluid3D([1717,1832,1816,1861],0); -ELEMENTS[59045] = Fluid3D([12023,11896,11004,11989],0); -ELEMENTS[59046] = Fluid3D([9657,8749,9693,9485],0); -ELEMENTS[59047] = Fluid3D([9657,8749,9485,9052],0); -ELEMENTS[59048] = Fluid3D([9485,9657,9052,10515],0); -ELEMENTS[59049] = Fluid3D([9693,9657,9485,10639],0); -ELEMENTS[59050] = Fluid3D([8094,8964,9084,9200],0); -ELEMENTS[59051] = Fluid3D([6500,7257,7165,7477],0); -ELEMENTS[59052] = Fluid3D([4788,4835,4365,5033],0); -ELEMENTS[59053] = Fluid3D([4788,4835,5033,5307],0); -ELEMENTS[59054] = Fluid3D([4365,4788,5033,4653],0); -ELEMENTS[59055] = Fluid3D([4788,5033,4653,5319],0); -ELEMENTS[59056] = Fluid3D([4788,5033,5319,5307],0); -ELEMENTS[59057] = Fluid3D([16398,16737,16480,15873],0); -ELEMENTS[59058] = Fluid3D([5010,5049,5406,4958],0); -ELEMENTS[59059] = Fluid3D([2853,3012,2704,2852],0); -ELEMENTS[59060] = Fluid3D([3012,2704,2852,2855],0); -ELEMENTS[59061] = Fluid3D([2704,2852,2855,2686],0); -ELEMENTS[59062] = Fluid3D([2704,2852,2686,2431],0); -ELEMENTS[59063] = Fluid3D([2704,2852,2431,2561],0); -ELEMENTS[59064] = Fluid3D([2704,2853,2852,2561],0); -ELEMENTS[59065] = Fluid3D([2001,2213,2030,2086],0); -ELEMENTS[59066] = Fluid3D([2213,2030,2086,2266],0); -ELEMENTS[59067] = Fluid3D([2030,2086,2266,2080],0); -ELEMENTS[59068] = Fluid3D([2030,2086,2080,1879],0); -ELEMENTS[59069] = Fluid3D([2030,2001,2086,1839],0); -ELEMENTS[59070] = Fluid3D([2030,2086,1879,1839],0); -ELEMENTS[59071] = Fluid3D([11933,12106,11436,12328],0); -ELEMENTS[59072] = Fluid3D([2637,2752,2800,2602],0); -ELEMENTS[59073] = Fluid3D([16526,16716,16359,16124],0); -ELEMENTS[59074] = Fluid3D([13439,13923,13801,13218],0); -ELEMENTS[59075] = Fluid3D([13923,13801,13218,14284],0); -ELEMENTS[59076] = Fluid3D([13801,13439,13218,13299],0); -ELEMENTS[59077] = Fluid3D([13439,13923,13218,12950],0); -ELEMENTS[59078] = Fluid3D([13923,13218,12950,13334],0); -ELEMENTS[59079] = Fluid3D([13218,13439,12950,12541],0); -ELEMENTS[59080] = Fluid3D([12950,13218,12541,12652],0); -ELEMENTS[59081] = Fluid3D([12950,13218,12652,13334],0); -ELEMENTS[59082] = Fluid3D([13218,13439,12541,13299],0); -ELEMENTS[59083] = Fluid3D([13218,12541,12652,12887],0); -ELEMENTS[59084] = Fluid3D([12652,13218,12887,13801],0); -ELEMENTS[59085] = Fluid3D([13218,12541,12887,13299],0); -ELEMENTS[59086] = Fluid3D([13218,12887,13801,13299],0); -ELEMENTS[59087] = Fluid3D([14913,14993,14542,14335],0); -ELEMENTS[59088] = Fluid3D([2806,2692,3002,3236],0); -ELEMENTS[59089] = Fluid3D([4899,4905,4408,4385],0); -ELEMENTS[59090] = Fluid3D([15133,14404,14552,13926],0); -ELEMENTS[59091] = Fluid3D([14404,14552,13926,13774],0); -ELEMENTS[59092] = Fluid3D([14552,13926,13774,13932],0); -ELEMENTS[59093] = Fluid3D([13926,14404,13774,13616],0); -ELEMENTS[59094] = Fluid3D([17698,17797,17538,17457],0); -ELEMENTS[59095] = Fluid3D([14328,14763,14307,13646],0); -ELEMENTS[59096] = Fluid3D([14307,14328,13646,13865],0); -ELEMENTS[59097] = Fluid3D([16733,16462,16813,16237],0); -ELEMENTS[59098] = Fluid3D([14433,13555,13763,13957],0); -ELEMENTS[59099] = Fluid3D([7868,7171,8216,7608],0); -ELEMENTS[59100] = Fluid3D([17675,18000,17914,17688],0); -ELEMENTS[59101] = Fluid3D([16908,17197,17167,16611],0); -ELEMENTS[59102] = Fluid3D([17167,16908,16611,16874],0); -ELEMENTS[59103] = Fluid3D([16908,16611,16874,16588],0); -ELEMENTS[59104] = Fluid3D([16908,16611,16588,16632],0); -ELEMENTS[59105] = Fluid3D([16908,16611,16632,16955],0); -ELEMENTS[59106] = Fluid3D([16908,16611,16955,17197],0); -ELEMENTS[59107] = Fluid3D([10388,11085,9955,10967],0); -ELEMENTS[59108] = Fluid3D([11085,9955,10967,10695],0); -ELEMENTS[59109] = Fluid3D([10967,11085,10695,11798],0); -ELEMENTS[59110] = Fluid3D([10967,11085,11798,12175],0); -ELEMENTS[59111] = Fluid3D([10388,11085,10967,11516],0); -ELEMENTS[59112] = Fluid3D([10967,11085,12175,11516],0); -ELEMENTS[59113] = Fluid3D([15551,15972,15799,15389],0); -ELEMENTS[59114] = Fluid3D([8595,9290,8432,9240],0); -ELEMENTS[59115] = Fluid3D([5321,5593,6065,5379],0); -ELEMENTS[59116] = Fluid3D([17988,18247,18186,17877],0); -ELEMENTS[59117] = Fluid3D([18611,18597,18538,18526],0); -ELEMENTS[59118] = Fluid3D([18597,18538,18526,18421],0); -ELEMENTS[59119] = Fluid3D([18538,18526,18421,18562],0); -ELEMENTS[59120] = Fluid3D([18538,18611,18526,18562],0); -ELEMENTS[59121] = Fluid3D([18611,18597,18526,18646],0); -ELEMENTS[59122] = Fluid3D([4060,4284,4571,4804],0); -ELEMENTS[59123] = Fluid3D([18327,18358,18323,18456],0); -ELEMENTS[59124] = Fluid3D([11213,11510,12172,11505],0); -ELEMENTS[59125] = Fluid3D([11510,12172,11505,12453],0); -ELEMENTS[59126] = Fluid3D([11213,11510,11505,10517],0); -ELEMENTS[59127] = Fluid3D([11505,11510,12453,10911],0); -ELEMENTS[59128] = Fluid3D([11505,11510,10911,10517],0); -ELEMENTS[59129] = Fluid3D([11510,10911,10517,10827],0); -ELEMENTS[59130] = Fluid3D([11510,10911,10827,11803],0); -ELEMENTS[59131] = Fluid3D([10911,10827,11803,11133],0); -ELEMENTS[59132] = Fluid3D([11510,10911,11803,12453],0); -ELEMENTS[59133] = Fluid3D([10911,10517,10827,9884],0); -ELEMENTS[59134] = Fluid3D([10827,10911,9884,10326],0); -ELEMENTS[59135] = Fluid3D([12172,11213,11505,11658],0); -ELEMENTS[59136] = Fluid3D([12172,11505,12453,12108],0); -ELEMENTS[59137] = Fluid3D([8139,7292,7756,8184],0); -ELEMENTS[59138] = Fluid3D([8139,7292,8184,8298],0); -ELEMENTS[59139] = Fluid3D([8184,8139,8298,9141],0); -ELEMENTS[59140] = Fluid3D([7756,8139,8184,8642],0); -ELEMENTS[59141] = Fluid3D([7292,7756,8184,7772],0); -ELEMENTS[59142] = Fluid3D([18570,18604,18523,18504],0); -ELEMENTS[59143] = Fluid3D([2276,2509,2320,2649],0); -ELEMENTS[59144] = Fluid3D([17421,17096,17551,17369],0); -ELEMENTS[59145] = Fluid3D([17421,17096,17369,16961],0); -ELEMENTS[59146] = Fluid3D([17551,17421,17369,17822],0); -ELEMENTS[59147] = Fluid3D([14964,15233,15409,14703],0); -ELEMENTS[59148] = Fluid3D([14964,15233,14703,14279],0); -ELEMENTS[59149] = Fluid3D([14703,14964,14279,14270],0); -ELEMENTS[59150] = Fluid3D([14279,14703,14270,14674],0); -ELEMENTS[59151] = Fluid3D([14703,14270,14674,14865],0); -ELEMENTS[59152] = Fluid3D([14703,14270,14865,15149],0); -ELEMENTS[59153] = Fluid3D([14674,14703,14865,15659],0); -ELEMENTS[59154] = Fluid3D([15233,15409,14703,15659],0); -ELEMENTS[59155] = Fluid3D([15409,14964,14703,15149],0); -ELEMENTS[59156] = Fluid3D([14703,14964,14270,15149],0); -ELEMENTS[59157] = Fluid3D([14279,14703,14674,15233],0); -ELEMENTS[59158] = Fluid3D([14703,14674,15233,15659],0); -ELEMENTS[59159] = Fluid3D([3339,3126,3504,3308],0); -ELEMENTS[59160] = Fluid3D([18136,18180,17991,17818],0); -ELEMENTS[59161] = Fluid3D([8982,9872,9133,9703],0); -ELEMENTS[59162] = Fluid3D([8982,9872,9703,9720],0); -ELEMENTS[59163] = Fluid3D([9133,8982,9703,8755],0); -ELEMENTS[59164] = Fluid3D([9872,9133,9703,10572],0); -ELEMENTS[59165] = Fluid3D([9703,9872,10572,10795],0); -ELEMENTS[59166] = Fluid3D([9703,9133,8755,9662],0); -ELEMENTS[59167] = Fluid3D([9133,8755,9662,9447],0); -ELEMENTS[59168] = Fluid3D([9703,9133,9662,10572],0); -ELEMENTS[59169] = Fluid3D([8755,9662,9447,8866],0); -ELEMENTS[59170] = Fluid3D([9662,9447,8866,10287],0); -ELEMENTS[59171] = Fluid3D([9447,8755,8866,8442],0); -ELEMENTS[59172] = Fluid3D([12094,11753,11599,10822],0); -ELEMENTS[59173] = Fluid3D([7551,6721,7082,7581],0); -ELEMENTS[59174] = Fluid3D([7551,6721,7581,7155],0); -ELEMENTS[59175] = Fluid3D([7581,7551,7155,8020],0); -ELEMENTS[59176] = Fluid3D([7082,7551,7581,7939],0); -ELEMENTS[59177] = Fluid3D([18500,18581,18569,18499],0); -ELEMENTS[59178] = Fluid3D([2605,2888,2826,2883],0); -ELEMENTS[59179] = Fluid3D([2826,2605,2883,2556],0); -ELEMENTS[59180] = Fluid3D([2883,2826,2556,2777],0); -ELEMENTS[59181] = Fluid3D([10059,10041,10739,10970],0); -ELEMENTS[59182] = Fluid3D([16939,16586,16797,16498],0); -ELEMENTS[59183] = Fluid3D([16797,16939,16498,17111],0); -ELEMENTS[59184] = Fluid3D([16586,16797,16498,16439],0); -ELEMENTS[59185] = Fluid3D([16498,16797,17111,16997],0); -ELEMENTS[59186] = Fluid3D([16797,16498,16439,16663],0); -ELEMENTS[59187] = Fluid3D([2487,2630,2765,2845],0); -ELEMENTS[59188] = Fluid3D([2630,2765,2845,2941],0); -ELEMENTS[59189] = Fluid3D([2765,2487,2845,2607],0); -ELEMENTS[59190] = Fluid3D([5895,5846,5338,6143],0); -ELEMENTS[59191] = Fluid3D([5895,5846,6143,6444],0); -ELEMENTS[59192] = Fluid3D([6398,6961,6209,6311],0); -ELEMENTS[59193] = Fluid3D([6398,6961,6311,7186],0); -ELEMENTS[59194] = Fluid3D([6209,6398,6311,5873],0); -ELEMENTS[59195] = Fluid3D([6398,6311,5873,6632],0); -ELEMENTS[59196] = Fluid3D([6209,6398,5873,5760],0); -ELEMENTS[59197] = Fluid3D([6398,5873,5760,5946],0); -ELEMENTS[59198] = Fluid3D([6398,5873,5946,6632],0); -ELEMENTS[59199] = Fluid3D([5873,5760,5946,5341],0); -ELEMENTS[59200] = Fluid3D([6311,6398,7186,6632],0); -ELEMENTS[59201] = Fluid3D([13554,12892,13118,13051],0); -ELEMENTS[59202] = Fluid3D([11741,11248,11498,11089],0); -ELEMENTS[59203] = Fluid3D([16749,17072,16966,16389],0); -ELEMENTS[59204] = Fluid3D([10021,11041,10627,11237],0); -ELEMENTS[59205] = Fluid3D([15084,14620,14823,14268],0); -ELEMENTS[59206] = Fluid3D([15084,14620,14268,14906],0); -ELEMENTS[59207] = Fluid3D([16216,16321,15937,15875],0); -ELEMENTS[59208] = Fluid3D([16321,15937,15875,16048],0); -ELEMENTS[59209] = Fluid3D([16216,16321,15875,16566],0); -ELEMENTS[59210] = Fluid3D([12505,13517,12702,13016],0); -ELEMENTS[59211] = Fluid3D([15734,15271,16042,15661],0); -ELEMENTS[59212] = Fluid3D([15734,15271,15661,15335],0); -ELEMENTS[59213] = Fluid3D([12716,13104,13202,12416],0); -ELEMENTS[59214] = Fluid3D([1917,2072,1969,2193],0); -ELEMENTS[59215] = Fluid3D([14961,14872,14023,14289],0); -ELEMENTS[59216] = Fluid3D([18498,18331,18386,18380],0); -ELEMENTS[59217] = Fluid3D([17742,17976,17916,17783],0); -ELEMENTS[59218] = Fluid3D([17976,17916,17783,18126],0); -ELEMENTS[59219] = Fluid3D([17783,17976,18126,18167],0); -ELEMENTS[59220] = Fluid3D([8329,8193,9102,8808],0); -ELEMENTS[59221] = Fluid3D([8329,8193,8808,7786],0); -ELEMENTS[59222] = Fluid3D([14522,14995,14838,14267],0); -ELEMENTS[59223] = Fluid3D([14688,13964,14837,13716],0); -ELEMENTS[59224] = Fluid3D([14688,13964,13716,14105],0); -ELEMENTS[59225] = Fluid3D([15966,16529,16239,15745],0); -ELEMENTS[59226] = Fluid3D([14037,14232,14522,13275],0); -ELEMENTS[59227] = Fluid3D([13739,13736,13842,12754],0); -ELEMENTS[59228] = Fluid3D([14300,14259,13428,13592],0); -ELEMENTS[59229] = Fluid3D([17611,17411,17680,17207],0); -ELEMENTS[59230] = Fluid3D([13706,13497,12842,12636],0); -ELEMENTS[59231] = Fluid3D([12842,13706,12636,13086],0); -ELEMENTS[59232] = Fluid3D([12636,12842,13086,12172],0); -ELEMENTS[59233] = Fluid3D([9604,9912,10573,10364],0); -ELEMENTS[59234] = Fluid3D([9912,10573,10364,10914],0); -ELEMENTS[59235] = Fluid3D([10364,9912,10914,10244],0); -ELEMENTS[59236] = Fluid3D([10364,9912,10244,9280],0); -ELEMENTS[59237] = Fluid3D([9604,9912,10364,8979],0); -ELEMENTS[59238] = Fluid3D([10364,9912,9280,8979],0); -ELEMENTS[59239] = Fluid3D([18595,18517,18568,18452],0); -ELEMENTS[59240] = Fluid3D([11734,11356,11265,11296],0); -ELEMENTS[59241] = Fluid3D([11734,11356,11296,11826],0); -ELEMENTS[59242] = Fluid3D([11296,11734,11826,12225],0); -ELEMENTS[59243] = Fluid3D([11296,11734,12225,12143],0); -ELEMENTS[59244] = Fluid3D([11265,11734,11296,11667],0); -ELEMENTS[59245] = Fluid3D([11296,11734,12143,11667],0); -ELEMENTS[59246] = Fluid3D([11356,11296,11826,10535],0); -ELEMENTS[59247] = Fluid3D([2028,2160,2207,2263],0); -ELEMENTS[59248] = Fluid3D([2028,2160,2263,1995],0); -ELEMENTS[59249] = Fluid3D([2160,2263,1995,2124],0); -ELEMENTS[59250] = Fluid3D([6875,6614,7015,7731],0); -ELEMENTS[59251] = Fluid3D([14166,14514,14928,14605],0); -ELEMENTS[59252] = Fluid3D([18356,18466,18476,18257],0); -ELEMENTS[59253] = Fluid3D([18356,18466,18257,18342],0); -ELEMENTS[59254] = Fluid3D([3835,3930,3523,4292],0); -ELEMENTS[59255] = Fluid3D([4504,4022,4274,4912],0); -ELEMENTS[59256] = Fluid3D([18594,18564,18512,18460],0); -ELEMENTS[59257] = Fluid3D([2211,2346,2312,2106],0); -ELEMENTS[59258] = Fluid3D([2211,2346,2106,2144],0); -ELEMENTS[59259] = Fluid3D([18027,18170,17985,17992],0); -ELEMENTS[59260] = Fluid3D([10138,10773,11046,10406],0); -ELEMENTS[59261] = Fluid3D([11133,11813,12117,12743],0); -ELEMENTS[59262] = Fluid3D([12209,11920,11332,12292],0); -ELEMENTS[59263] = Fluid3D([6967,7607,6823,7594],0); -ELEMENTS[59264] = Fluid3D([8500,9156,8134,8424],0); -ELEMENTS[59265] = Fluid3D([8500,9156,8424,8009],0); -ELEMENTS[59266] = Fluid3D([5814,5274,5791,5976],0); -ELEMENTS[59267] = Fluid3D([5791,5814,5976,6399],0); -ELEMENTS[59268] = Fluid3D([5814,5274,5976,5307],0); -ELEMENTS[59269] = Fluid3D([5976,5814,5307,5772],0); -ELEMENTS[59270] = Fluid3D([2354,2542,2280,2476],0); -ELEMENTS[59271] = Fluid3D([4284,4510,4796,4973],0); -ELEMENTS[59272] = Fluid3D([18469,18435,18340,18350],0); -ELEMENTS[59273] = Fluid3D([8025,8293,8894,8484],0); -ELEMENTS[59274] = Fluid3D([8894,8025,8484,8630],0); -ELEMENTS[59275] = Fluid3D([8484,8894,8630,9547],0); -ELEMENTS[59276] = Fluid3D([8484,8894,9547,9829],0); -ELEMENTS[59277] = Fluid3D([8293,8894,8484,9188],0); -ELEMENTS[59278] = Fluid3D([8025,8484,8630,7422],0); -ELEMENTS[59279] = Fluid3D([8025,8484,7422,7663],0); -ELEMENTS[59280] = Fluid3D([8484,8894,9829,9188],0); -ELEMENTS[59281] = Fluid3D([10021,9441,10441,10688],0); -ELEMENTS[59282] = Fluid3D([7486,7578,7985,7264],0); -ELEMENTS[59283] = Fluid3D([8268,7756,7417,7990],0); -ELEMENTS[59284] = Fluid3D([18257,18356,18198,18476],0); -ELEMENTS[59285] = Fluid3D([15372,15501,15068,14514],0); -ELEMENTS[59286] = Fluid3D([15068,15372,14514,14928],0); -ELEMENTS[59287] = Fluid3D([14514,15068,14928,14605],0); -ELEMENTS[59288] = Fluid3D([5529,5624,6118,6255],0); -ELEMENTS[59289] = Fluid3D([13991,13280,14073,13628],0); -ELEMENTS[59290] = Fluid3D([13991,13280,13628,13201],0); -ELEMENTS[59291] = Fluid3D([13628,13991,13201,13945],0); -ELEMENTS[59292] = Fluid3D([13628,13991,13945,14689],0); -ELEMENTS[59293] = Fluid3D([13628,13991,14689,14750],0); -ELEMENTS[59294] = Fluid3D([3986,3482,3528,3844],0); -ELEMENTS[59295] = Fluid3D([18559,18612,18621,18558],0); -ELEMENTS[59296] = Fluid3D([8020,8418,8923,8530],0); -ELEMENTS[59297] = Fluid3D([8923,8020,8530,8514],0); -ELEMENTS[59298] = Fluid3D([8020,8418,8530,7581],0); -ELEMENTS[59299] = Fluid3D([8020,8530,8514,8033],0); -ELEMENTS[59300] = Fluid3D([8020,8530,8033,7581],0); -ELEMENTS[59301] = Fluid3D([6892,6874,6789,6137],0); -ELEMENTS[59302] = Fluid3D([6789,6892,6137,6949],0); -ELEMENTS[59303] = Fluid3D([6137,6789,6949,6822],0); -ELEMENTS[59304] = Fluid3D([10628,11128,11758,11461],0); -ELEMENTS[59305] = Fluid3D([17167,17142,16874,16444],0); -ELEMENTS[59306] = Fluid3D([16663,16439,16310,15718],0); -ELEMENTS[59307] = Fluid3D([16841,16990,16651,16457],0); -ELEMENTS[59308] = Fluid3D([16651,16841,16457,16478],0); -ELEMENTS[59309] = Fluid3D([2941,2806,3130,3386],0); -ELEMENTS[59310] = Fluid3D([10823,11754,11600,12095],0); -ELEMENTS[59311] = Fluid3D([2175,2254,2391,2507],0); -ELEMENTS[59312] = Fluid3D([2497,2595,2772,2718],0); -ELEMENTS[59313] = Fluid3D([16829,16302,16503,16374],0); -ELEMENTS[59314] = Fluid3D([16503,16829,16374,17010],0); -ELEMENTS[59315] = Fluid3D([16302,16503,16374,15934],0); -ELEMENTS[59316] = Fluid3D([16829,16302,16374,16639],0); -ELEMENTS[59317] = Fluid3D([16858,16630,16966,16201],0); -ELEMENTS[59318] = Fluid3D([16858,16630,16201,16501],0); -ELEMENTS[59319] = Fluid3D([16630,16201,16501,16269],0); -ELEMENTS[59320] = Fluid3D([16630,16201,16269,16391],0); -ELEMENTS[59321] = Fluid3D([16630,16201,16391,16749],0); -ELEMENTS[59322] = Fluid3D([16201,16501,16269,15716],0); -ELEMENTS[59323] = Fluid3D([16080,16267,16631,15951],0); -ELEMENTS[59324] = Fluid3D([16080,16267,15951,15660],0); -ELEMENTS[59325] = Fluid3D([18379,18325,18457,18270],0); -ELEMENTS[59326] = Fluid3D([10750,9777,10484,10814],0); -ELEMENTS[59327] = Fluid3D([10702,11714,11646,11914],0); -ELEMENTS[59328] = Fluid3D([11714,11646,11914,12947],0); -ELEMENTS[59329] = Fluid3D([12138,12452,12663,11495],0); -ELEMENTS[59330] = Fluid3D([14929,15191,14440,14843],0); -ELEMENTS[59331] = Fluid3D([4394,4310,3937,3780],0); -ELEMENTS[59332] = Fluid3D([6581,5918,6391,6102],0); -ELEMENTS[59333] = Fluid3D([17766,17990,17816,17666],0); -ELEMENTS[59334] = Fluid3D([18657,18610,18626,18574],0); -ELEMENTS[59335] = Fluid3D([11069,11818,10739,11214],0); -ELEMENTS[59336] = Fluid3D([11069,11818,11214,12150],0); -ELEMENTS[59337] = Fluid3D([11818,10739,11214,11693],0); -ELEMENTS[59338] = Fluid3D([11214,11818,11693,12441],0); -ELEMENTS[59339] = Fluid3D([10739,11069,11214,10534],0); -ELEMENTS[59340] = Fluid3D([11214,10739,10534,10970],0); -ELEMENTS[59341] = Fluid3D([11069,11214,10534,11249],0); -ELEMENTS[59342] = Fluid3D([11214,10534,11249,11387],0); -ELEMENTS[59343] = Fluid3D([11214,10534,11387,10970],0); -ELEMENTS[59344] = Fluid3D([11069,11214,11249,12150],0); -ELEMENTS[59345] = Fluid3D([11249,11214,11387,12441],0); -ELEMENTS[59346] = Fluid3D([11387,11214,10970,11693],0); -ELEMENTS[59347] = Fluid3D([11387,11214,11693,12441],0); -ELEMENTS[59348] = Fluid3D([15934,15546,16169,15800],0); -ELEMENTS[59349] = Fluid3D([2738,2699,2476,2844],0); -ELEMENTS[59350] = Fluid3D([17665,17871,17642,17356],0); -ELEMENTS[59351] = Fluid3D([14058,14255,14564,14868],0); -ELEMENTS[59352] = Fluid3D([15583,15409,15820,14865],0); -ELEMENTS[59353] = Fluid3D([6953,6553,6805,7112],0); -ELEMENTS[59354] = Fluid3D([8860,8036,8133,8758],0); -ELEMENTS[59355] = Fluid3D([8860,8036,8758,8765],0); -ELEMENTS[59356] = Fluid3D([9056,8179,8403,8349],0); -ELEMENTS[59357] = Fluid3D([8179,8403,8349,7428],0); -ELEMENTS[59358] = Fluid3D([8403,8349,7428,7587],0); -ELEMENTS[59359] = Fluid3D([8349,7428,7587,8453],0); -ELEMENTS[59360] = Fluid3D([8349,7428,8453,7519],0); -ELEMENTS[59361] = Fluid3D([8349,8179,7428,7744],0); -ELEMENTS[59362] = Fluid3D([7428,8349,7744,7519],0); -ELEMENTS[59363] = Fluid3D([8349,7744,7519,8675],0); -ELEMENTS[59364] = Fluid3D([7744,7428,7519,7429],0); -ELEMENTS[59365] = Fluid3D([7519,7744,7429,7932],0); -ELEMENTS[59366] = Fluid3D([8349,8179,7744,8853],0); -ELEMENTS[59367] = Fluid3D([8403,9056,8349,9275],0); -ELEMENTS[59368] = Fluid3D([9056,8179,8349,8853],0); -ELEMENTS[59369] = Fluid3D([7744,7519,8675,8045],0); -ELEMENTS[59370] = Fluid3D([7744,7519,8045,7932],0); -ELEMENTS[59371] = Fluid3D([8045,7744,7932,8853],0); -ELEMENTS[59372] = Fluid3D([7519,8045,7932,7856],0); -ELEMENTS[59373] = Fluid3D([8045,7932,7856,8898],0); -ELEMENTS[59374] = Fluid3D([7519,8045,7856,8675],0); -ELEMENTS[59375] = Fluid3D([7744,7428,7429,8179],0); -ELEMENTS[59376] = Fluid3D([5893,6306,6021,6393],0); -ELEMENTS[59377] = Fluid3D([6021,5893,6393,5978],0); -ELEMENTS[59378] = Fluid3D([4651,4562,5079,4829],0); -ELEMENTS[59379] = Fluid3D([4651,4562,4829,4173],0); -ELEMENTS[59380] = Fluid3D([12394,12158,11909,13027],0); -ELEMENTS[59381] = Fluid3D([4819,4946,4413,4606],0); -ELEMENTS[59382] = Fluid3D([14913,14542,14449,14021],0); -ELEMENTS[59383] = Fluid3D([8818,7922,8468,8897],0); -ELEMENTS[59384] = Fluid3D([8468,8818,8897,9386],0); -ELEMENTS[59385] = Fluid3D([7922,8468,8897,7616],0); -ELEMENTS[59386] = Fluid3D([7262,8149,8046,7425],0); -ELEMENTS[59387] = Fluid3D([12760,12638,11867,11581],0); -ELEMENTS[59388] = Fluid3D([4376,4496,4891,4462],0); -ELEMENTS[59389] = Fluid3D([4376,4496,4462,4031],0); -ELEMENTS[59390] = Fluid3D([4462,4376,4031,3946],0); -ELEMENTS[59391] = Fluid3D([4891,4376,4462,4751],0); -ELEMENTS[59392] = Fluid3D([6690,6013,6645,5757],0); -ELEMENTS[59393] = Fluid3D([7861,8464,8753,9230],0); -ELEMENTS[59394] = Fluid3D([18543,18481,18448,18344],0); -ELEMENTS[59395] = Fluid3D([12832,12964,12461,11941],0); -ELEMENTS[59396] = Fluid3D([12461,12832,11941,12329],0); -ELEMENTS[59397] = Fluid3D([12832,11941,12329,12716],0); -ELEMENTS[59398] = Fluid3D([16042,15982,15661,15279],0); -ELEMENTS[59399] = Fluid3D([15982,15661,15279,15601],0); -ELEMENTS[59400] = Fluid3D([15661,15279,15601,15266],0); -ELEMENTS[59401] = Fluid3D([10988,11753,11939,12265],0); -ELEMENTS[59402] = Fluid3D([3800,3644,3353,4075],0); -ELEMENTS[59403] = Fluid3D([3183,3443,3070,3594],0); -ELEMENTS[59404] = Fluid3D([3443,3070,3594,3328],0); -ELEMENTS[59405] = Fluid3D([3594,3443,3328,3716],0); -ELEMENTS[59406] = Fluid3D([3594,3443,3716,3847],0); -ELEMENTS[59407] = Fluid3D([3183,3443,3594,3572],0); -ELEMENTS[59408] = Fluid3D([3594,3443,3847,3572],0); -ELEMENTS[59409] = Fluid3D([13587,12989,13958,13084],0); -ELEMENTS[59410] = Fluid3D([18300,18126,18167,17969],0); -ELEMENTS[59411] = Fluid3D([11947,11477,11993,10893],0); -ELEMENTS[59412] = Fluid3D([9727,9759,10598,10040],0); -ELEMENTS[59413] = Fluid3D([9759,10598,10040,10654],0); -ELEMENTS[59414] = Fluid3D([10040,9759,10654,9814],0); -ELEMENTS[59415] = Fluid3D([10598,10040,10654,11513],0); -ELEMENTS[59416] = Fluid3D([9727,9759,10040,9112],0); -ELEMENTS[59417] = Fluid3D([9759,10040,9112,8778],0); -ELEMENTS[59418] = Fluid3D([9727,9759,9112,8922],0); -ELEMENTS[59419] = Fluid3D([9759,9112,8922,8967],0); -ELEMENTS[59420] = Fluid3D([9112,9759,8778,8967],0); -ELEMENTS[59421] = Fluid3D([9112,9727,8922,9284],0); -ELEMENTS[59422] = Fluid3D([9112,9727,9284,10040],0); -ELEMENTS[59423] = Fluid3D([10598,9727,10040,10512],0); -ELEMENTS[59424] = Fluid3D([10040,10598,10512,11513],0); -ELEMENTS[59425] = Fluid3D([8778,9112,8967,7935],0); -ELEMENTS[59426] = Fluid3D([9112,8922,8967,7935],0); -ELEMENTS[59427] = Fluid3D([10040,9759,9814,8778],0); -ELEMENTS[59428] = Fluid3D([8467,8405,8881,9355],0); -ELEMENTS[59429] = Fluid3D([2655,2498,2784,2674],0); -ELEMENTS[59430] = Fluid3D([2655,2498,2674,2391],0); -ELEMENTS[59431] = Fluid3D([2674,2655,2391,2548],0); -ELEMENTS[59432] = Fluid3D([16249,15926,15890,15556],0); -ELEMENTS[59433] = Fluid3D([16249,15926,15556,16292],0); -ELEMENTS[59434] = Fluid3D([10093,9307,9513,8850],0); -ELEMENTS[59435] = Fluid3D([16346,16632,16300,16194],0); -ELEMENTS[59436] = Fluid3D([2400,2248,2497,2493],0); -ELEMENTS[59437] = Fluid3D([7000,6714,6223,7061],0); -ELEMENTS[59438] = Fluid3D([14977,14212,14459,14612],0); -ELEMENTS[59439] = Fluid3D([15249,15389,14983,15799],0); -ELEMENTS[59440] = Fluid3D([15411,15236,14637,15549],0); -ELEMENTS[59441] = Fluid3D([13908,14376,13979,13544],0); -ELEMENTS[59442] = Fluid3D([13908,14376,13544,14314],0); -ELEMENTS[59443] = Fluid3D([4349,4223,3813,4210],0); -ELEMENTS[59444] = Fluid3D([4349,4223,4210,4780],0); -ELEMENTS[59445] = Fluid3D([4223,3813,4210,3991],0); -ELEMENTS[59446] = Fluid3D([4210,4223,3991,4517],0); -ELEMENTS[59447] = Fluid3D([4210,4223,4517,4780],0); -ELEMENTS[59448] = Fluid3D([4223,3991,4517,4480],0); -ELEMENTS[59449] = Fluid3D([3991,4210,4517,4644],0); -ELEMENTS[59450] = Fluid3D([4210,4517,4644,4780],0); -ELEMENTS[59451] = Fluid3D([4517,4644,4780,4977],0); -ELEMENTS[59452] = Fluid3D([4517,4644,4977,4577],0); -ELEMENTS[59453] = Fluid3D([4517,4644,4577,4102],0); -ELEMENTS[59454] = Fluid3D([4577,4517,4102,4480],0); -ELEMENTS[59455] = Fluid3D([4102,4577,4480,4479],0); -ELEMENTS[59456] = Fluid3D([4102,4577,4479,4644],0); -ELEMENTS[59457] = Fluid3D([4577,4517,4480,4977],0); -ELEMENTS[59458] = Fluid3D([4577,4480,4479,4955],0); -ELEMENTS[59459] = Fluid3D([4479,4577,4955,5139],0); -ELEMENTS[59460] = Fluid3D([4480,4577,4977,4955],0); -ELEMENTS[59461] = Fluid3D([4517,4480,4977,4223],0); -ELEMENTS[59462] = Fluid3D([4517,4102,4480,3991],0); -ELEMENTS[59463] = Fluid3D([4517,4102,3991,4644],0); -ELEMENTS[59464] = Fluid3D([4102,4480,3991,3739],0); -ELEMENTS[59465] = Fluid3D([3991,4102,3739,3595],0); -ELEMENTS[59466] = Fluid3D([4223,4517,4780,4977],0); -ELEMENTS[59467] = Fluid3D([4138,4498,4038,3867],0); -ELEMENTS[59468] = Fluid3D([4038,4138,3867,3693],0); -ELEMENTS[59469] = Fluid3D([4498,4038,3867,4394],0); -ELEMENTS[59470] = Fluid3D([4038,3867,4394,3937],0); -ELEMENTS[59471] = Fluid3D([4038,3867,3937,3620],0); -ELEMENTS[59472] = Fluid3D([4038,3867,3620,3693],0); -ELEMENTS[59473] = Fluid3D([6804,6503,7314,7167],0); -ELEMENTS[59474] = Fluid3D([12150,12864,11818,12441],0); -ELEMENTS[59475] = Fluid3D([12150,12864,12441,13166],0); -ELEMENTS[59476] = Fluid3D([12864,11818,12441,12563],0); -ELEMENTS[59477] = Fluid3D([11818,12150,12441,11214],0); -ELEMENTS[59478] = Fluid3D([14689,14750,15355,14694],0); -ELEMENTS[59479] = Fluid3D([14750,15355,14694,15408],0); -ELEMENTS[59480] = Fluid3D([14689,14750,14694,13628],0); -ELEMENTS[59481] = Fluid3D([14694,14750,15408,14817],0); -ELEMENTS[59482] = Fluid3D([15355,14689,14694,14357],0); -ELEMENTS[59483] = Fluid3D([14689,14694,14357,13628],0); -ELEMENTS[59484] = Fluid3D([14357,14689,13628,13945],0); -ELEMENTS[59485] = Fluid3D([14357,14689,13945,14797],0); -ELEMENTS[59486] = Fluid3D([14357,14689,14797,15301],0); -ELEMENTS[59487] = Fluid3D([14357,14689,15301,15355],0); -ELEMENTS[59488] = Fluid3D([9540,10018,8861,9258],0); -ELEMENTS[59489] = Fluid3D([13820,14236,14732,14307],0); -ELEMENTS[59490] = Fluid3D([9507,10136,9188,9679],0); -ELEMENTS[59491] = Fluid3D([10136,9188,9679,9829],0); -ELEMENTS[59492] = Fluid3D([9679,10136,9829,10827],0); -ELEMENTS[59493] = Fluid3D([9507,10136,9679,10490],0); -ELEMENTS[59494] = Fluid3D([9679,10136,10827,10326],0); -ELEMENTS[59495] = Fluid3D([9679,10136,10326,10490],0); -ELEMENTS[59496] = Fluid3D([8749,7838,7890,7841],0); -ELEMENTS[59497] = Fluid3D([12390,11986,13196,12040],0); -ELEMENTS[59498] = Fluid3D([12390,11986,12040,11560],0); -ELEMENTS[59499] = Fluid3D([9592,9820,9220,8515],0); -ELEMENTS[59500] = Fluid3D([7186,8025,7765,7422],0); -ELEMENTS[59501] = Fluid3D([7186,8025,7422,7453],0); -ELEMENTS[59502] = Fluid3D([8025,7765,7422,8630],0); -ELEMENTS[59503] = Fluid3D([10888,9870,10319,10998],0); -ELEMENTS[59504] = Fluid3D([12712,13082,12148,13461],0); -ELEMENTS[59505] = Fluid3D([12712,13082,13461,13615],0); -ELEMENTS[59506] = Fluid3D([13082,13461,13615,13962],0); -ELEMENTS[59507] = Fluid3D([17371,17062,17238,16965],0); -ELEMENTS[59508] = Fluid3D([15529,15102,15430,14627],0); -ELEMENTS[59509] = Fluid3D([13439,13073,13580,12541],0); -ELEMENTS[59510] = Fluid3D([16522,17041,16944,16999],0); -ELEMENTS[59511] = Fluid3D([10455,9458,10354,10169],0); -ELEMENTS[59512] = Fluid3D([6286,5810,5822,5864],0); -ELEMENTS[59513] = Fluid3D([8442,9133,9314,9447],0); -ELEMENTS[59514] = Fluid3D([5884,6138,5645,6206],0); -ELEMENTS[59515] = Fluid3D([11908,11440,12421,11229],0); -ELEMENTS[59516] = Fluid3D([16588,16262,16300,16010],0); -ELEMENTS[59517] = Fluid3D([16588,16262,16010,15879],0); -ELEMENTS[59518] = Fluid3D([16262,16010,15879,15297],0); -ELEMENTS[59519] = Fluid3D([16010,15879,15297,15565],0); -ELEMENTS[59520] = Fluid3D([16300,16588,16010,16194],0); -ELEMENTS[59521] = Fluid3D([16262,16300,16010,15940],0); -ELEMENTS[59522] = Fluid3D([16010,16588,15879,16068],0); -ELEMENTS[59523] = Fluid3D([15879,16010,16068,15565],0); -ELEMENTS[59524] = Fluid3D([16010,16068,15565,16194],0); -ELEMENTS[59525] = Fluid3D([15202,15861,15573,15071],0); -ELEMENTS[59526] = Fluid3D([15861,15573,15071,15597],0); -ELEMENTS[59527] = Fluid3D([7904,7489,6945,7458],0); -ELEMENTS[59528] = Fluid3D([14253,13430,14538,14084],0); -ELEMENTS[59529] = Fluid3D([14538,14253,14084,14772],0); -ELEMENTS[59530] = Fluid3D([14253,14084,14772,13881],0); -ELEMENTS[59531] = Fluid3D([14253,13430,14084,13319],0); -ELEMENTS[59532] = Fluid3D([13430,14084,13319,13561],0); -ELEMENTS[59533] = Fluid3D([13430,14084,13561,14538],0); -ELEMENTS[59534] = Fluid3D([13319,13430,13561,12864],0); -ELEMENTS[59535] = Fluid3D([14084,13319,13561,13837],0); -ELEMENTS[59536] = Fluid3D([13561,14084,13837,14457],0); -ELEMENTS[59537] = Fluid3D([14084,13837,14457,14729],0); -ELEMENTS[59538] = Fluid3D([13561,14084,14457,14538],0); -ELEMENTS[59539] = Fluid3D([14084,14457,14538,14772],0); -ELEMENTS[59540] = Fluid3D([14084,13319,13837,13881],0); -ELEMENTS[59541] = Fluid3D([14457,14084,14729,14772],0); -ELEMENTS[59542] = Fluid3D([14084,13837,14729,13881],0); -ELEMENTS[59543] = Fluid3D([13319,13837,13881,13166],0); -ELEMENTS[59544] = Fluid3D([14084,14253,13319,13881],0); -ELEMENTS[59545] = Fluid3D([14084,14729,14772,13881],0); -ELEMENTS[59546] = Fluid3D([14538,14253,14772,15298],0); -ELEMENTS[59547] = Fluid3D([13561,13319,12864,13837],0); -ELEMENTS[59548] = Fluid3D([13319,12864,13837,13166],0); -ELEMENTS[59549] = Fluid3D([15518,15708,15280,14935],0); -ELEMENTS[59550] = Fluid3D([15551,15337,15764,15111],0); -ELEMENTS[59551] = Fluid3D([15337,15764,15111,15544],0); -ELEMENTS[59552] = Fluid3D([15764,15111,15544,15967],0); -ELEMENTS[59553] = Fluid3D([9354,9070,9047,8416],0); -ELEMENTS[59554] = Fluid3D([10011,10947,10836,10653],0); -ELEMENTS[59555] = Fluid3D([3673,3623,4023,4071],0); -ELEMENTS[59556] = Fluid3D([3238,3409,3637,3603],0); -ELEMENTS[59557] = Fluid3D([3238,3409,3603,3040],0); -ELEMENTS[59558] = Fluid3D([3409,3637,3603,3818],0); -ELEMENTS[59559] = Fluid3D([17745,17465,17831,17744],0); -ELEMENTS[59560] = Fluid3D([17831,17745,17744,18052],0); -ELEMENTS[59561] = Fluid3D([17745,17744,18052,17988],0); -ELEMENTS[59562] = Fluid3D([17745,17744,17988,17668],0); -ELEMENTS[59563] = Fluid3D([16961,16575,17096,16652],0); -ELEMENTS[59564] = Fluid3D([14964,14473,14782,14279],0); -ELEMENTS[59565] = Fluid3D([14782,14964,14279,15233],0); -ELEMENTS[59566] = Fluid3D([15361,15777,15608,15296],0); -ELEMENTS[59567] = Fluid3D([15777,15608,15296,16026],0); -ELEMENTS[59568] = Fluid3D([15608,15296,16026,15295],0); -ELEMENTS[59569] = Fluid3D([15608,15361,15296,15190],0); -ELEMENTS[59570] = Fluid3D([6157,6329,6219,5743],0); -ELEMENTS[59571] = Fluid3D([7128,7339,7955,7612],0); -ELEMENTS[59572] = Fluid3D([17655,17690,17427,17176],0); -ELEMENTS[59573] = Fluid3D([5712,6361,6075,6796],0); -ELEMENTS[59574] = Fluid3D([6361,6075,6796,6825],0); -ELEMENTS[59575] = Fluid3D([6796,6361,6825,7155],0); -ELEMENTS[59576] = Fluid3D([14457,14729,15278,14772],0); -ELEMENTS[59577] = Fluid3D([18624,18668,18658,18630],0); -ELEMENTS[59578] = Fluid3D([18384,18406,18500,18281],0); -ELEMENTS[59579] = Fluid3D([18406,18500,18281,18515],0); -ELEMENTS[59580] = Fluid3D([18384,18406,18281,18265],0); -ELEMENTS[59581] = Fluid3D([15732,15901,16326,16058],0); -ELEMENTS[59582] = Fluid3D([15901,16326,16058,16461],0); -ELEMENTS[59583] = Fluid3D([16326,15732,16058,16161],0); -ELEMENTS[59584] = Fluid3D([17726,17583,17849,17407],0); -ELEMENTS[59585] = Fluid3D([17726,17583,17407,17455],0); -ELEMENTS[59586] = Fluid3D([17583,17407,17455,17300],0); -ELEMENTS[59587] = Fluid3D([17407,17726,17455,17606],0); -ELEMENTS[59588] = Fluid3D([5740,6272,5578,6363],0); -ELEMENTS[59589] = Fluid3D([16730,16376,16586,16014],0); -ELEMENTS[59590] = Fluid3D([2273,2154,2076,2253],0); -ELEMENTS[59591] = Fluid3D([2154,2076,2253,1987],0); -ELEMENTS[59592] = Fluid3D([2253,2154,1987,2052],0); -ELEMENTS[59593] = Fluid3D([2273,2154,2253,2374],0); -ELEMENTS[59594] = Fluid3D([2253,2154,2052,2327],0); -ELEMENTS[59595] = Fluid3D([2253,2154,2327,2374],0); -ELEMENTS[59596] = Fluid3D([9530,10354,9458,10169],0); -ELEMENTS[59597] = Fluid3D([6078,6338,5649,5882],0); -ELEMENTS[59598] = Fluid3D([5642,5998,5758,6463],0); -ELEMENTS[59599] = Fluid3D([17016,16881,16688,16700],0); -ELEMENTS[59600] = Fluid3D([6281,6670,5956,6616],0); -ELEMENTS[59601] = Fluid3D([6670,5956,6616,6566],0); -ELEMENTS[59602] = Fluid3D([11958,11275,10845,10833],0); -ELEMENTS[59603] = Fluid3D([4381,4916,4664,4950],0); -ELEMENTS[59604] = Fluid3D([11453,12420,12031,12319],0); -ELEMENTS[59605] = Fluid3D([12031,11453,12319,11041],0); -ELEMENTS[59606] = Fluid3D([11961,11469,11600,10662],0); -ELEMENTS[59607] = Fluid3D([5708,6315,5651,5967],0); -ELEMENTS[59608] = Fluid3D([16566,16665,16321,15875],0); -ELEMENTS[59609] = Fluid3D([10369,10575,11620,11393],0); -ELEMENTS[59610] = Fluid3D([10369,10575,11393,10800],0); -ELEMENTS[59611] = Fluid3D([10575,11620,11393,10800],0); -ELEMENTS[59612] = Fluid3D([8156,8468,7616,8806],0); -ELEMENTS[59613] = Fluid3D([12759,12345,11791,11802],0); -ELEMENTS[59614] = Fluid3D([17418,17538,17238,17130],0); -ELEMENTS[59615] = Fluid3D([17418,17538,17130,17698],0); -ELEMENTS[59616] = Fluid3D([17538,17238,17130,16965],0); -ELEMENTS[59617] = Fluid3D([17238,17418,17130,16963],0); -ELEMENTS[59618] = Fluid3D([17418,17130,16963,17277],0); -ELEMENTS[59619] = Fluid3D([13613,14120,13827,12921],0); -ELEMENTS[59620] = Fluid3D([12548,13039,12628,11993],0); -ELEMENTS[59621] = Fluid3D([12628,12548,11993,12143],0); -ELEMENTS[59622] = Fluid3D([13039,12628,11993,13104],0); -ELEMENTS[59623] = Fluid3D([12548,13039,11993,12983],0); -ELEMENTS[59624] = Fluid3D([16346,16042,16393,15846],0); -ELEMENTS[59625] = Fluid3D([16346,16042,15846,15480],0); -ELEMENTS[59626] = Fluid3D([16042,16393,15846,15845],0); -ELEMENTS[59627] = Fluid3D([12980,13598,13688,14106],0); -ELEMENTS[59628] = Fluid3D([14123,13505,14417,14202],0); -ELEMENTS[59629] = Fluid3D([16468,16297,16778,16772],0); -ELEMENTS[59630] = Fluid3D([2047,2071,1992,1848],0); -ELEMENTS[59631] = Fluid3D([14995,14726,15185,14261],0); -ELEMENTS[59632] = Fluid3D([14995,14726,14261,14522],0); -ELEMENTS[59633] = Fluid3D([15439,15860,16127,15832],0); -ELEMENTS[59634] = Fluid3D([8922,8146,8967,7935],0); -ELEMENTS[59635] = Fluid3D([6311,5819,6542,6729],0); -ELEMENTS[59636] = Fluid3D([16639,16083,16302,16154],0); -ELEMENTS[59637] = Fluid3D([16639,16083,16154,16442],0); -ELEMENTS[59638] = Fluid3D([16302,16639,16154,16374],0); -ELEMENTS[59639] = Fluid3D([16083,16302,16154,15654],0); -ELEMENTS[59640] = Fluid3D([16154,16302,16374,15654],0); -ELEMENTS[59641] = Fluid3D([8078,8979,8664,8803],0); -ELEMENTS[59642] = Fluid3D([8664,8078,8803,7789],0); -ELEMENTS[59643] = Fluid3D([8803,8664,7789,8416],0); -ELEMENTS[59644] = Fluid3D([8803,8664,8416,9354],0); -ELEMENTS[59645] = Fluid3D([8803,8664,9354,9950],0); -ELEMENTS[59646] = Fluid3D([12172,12842,11910,11658],0); -ELEMENTS[59647] = Fluid3D([2276,2124,2094,2288],0); -ELEMENTS[59648] = Fluid3D([2276,2124,2288,2320],0); -ELEMENTS[59649] = Fluid3D([2124,2094,2288,1964],0); -ELEMENTS[59650] = Fluid3D([15784,15067,15236,15162],0); -ELEMENTS[59651] = Fluid3D([15067,15236,15162,14433],0); -ELEMENTS[59652] = Fluid3D([7872,7450,8116,6923],0); -ELEMENTS[59653] = Fluid3D([5334,5799,5221,5379],0); -ELEMENTS[59654] = Fluid3D([5799,5221,5379,5705],0); -ELEMENTS[59655] = Fluid3D([5379,5799,5705,6293],0); -ELEMENTS[59656] = Fluid3D([5221,5379,5705,5142],0); -ELEMENTS[59657] = Fluid3D([3828,4134,3632,3755],0); -ELEMENTS[59658] = Fluid3D([17690,17915,17717,17484],0); -ELEMENTS[59659] = Fluid3D([4081,4509,4083,4320],0); -ELEMENTS[59660] = Fluid3D([18233,18390,18337,18191],0); -ELEMENTS[59661] = Fluid3D([15414,15896,15273,15422],0); -ELEMENTS[59662] = Fluid3D([15414,15896,15422,15633],0); -ELEMENTS[59663] = Fluid3D([15273,15414,15422,14723],0); -ELEMENTS[59664] = Fluid3D([15896,15273,15422,15779],0); -ELEMENTS[59665] = Fluid3D([15422,15414,15633,15022],0); -ELEMENTS[59666] = Fluid3D([15896,15422,15633,15381],0); -ELEMENTS[59667] = Fluid3D([15422,15633,15381,15022],0); -ELEMENTS[59668] = Fluid3D([15633,15381,15022,15346],0); -ELEMENTS[59669] = Fluid3D([15414,15422,14723,14774],0); -ELEMENTS[59670] = Fluid3D([15414,15422,14774,15022],0); -ELEMENTS[59671] = Fluid3D([15896,15422,15381,15779],0); -ELEMENTS[59672] = Fluid3D([2956,3190,3273,3260],0); -ELEMENTS[59673] = Fluid3D([11084,11150,10313,11392],0); -ELEMENTS[59674] = Fluid3D([11084,11150,11392,12112],0); -ELEMENTS[59675] = Fluid3D([11150,11392,12112,11541],0); -ELEMENTS[59676] = Fluid3D([12112,11150,11541,11320],0); -ELEMENTS[59677] = Fluid3D([11150,11541,11320,10783],0); -ELEMENTS[59678] = Fluid3D([11150,10313,11392,11541],0); -ELEMENTS[59679] = Fluid3D([11150,10313,11541,10783],0); -ELEMENTS[59680] = Fluid3D([11150,10313,10783,11320],0); -ELEMENTS[59681] = Fluid3D([11150,10313,11320,10458],0); -ELEMENTS[59682] = Fluid3D([13209,13726,12722,13452],0); -ELEMENTS[59683] = Fluid3D([16114,16293,16483,16006],0); -ELEMENTS[59684] = Fluid3D([16483,16114,16006,16334],0); -ELEMENTS[59685] = Fluid3D([16006,16483,16334,16688],0); -ELEMENTS[59686] = Fluid3D([16114,16006,16334,15441],0); -ELEMENTS[59687] = Fluid3D([4529,4198,4045,4493],0); -ELEMENTS[59688] = Fluid3D([6240,6260,7035,6110],0); -ELEMENTS[59689] = Fluid3D([13905,13395,13678,12936],0); -ELEMENTS[59690] = Fluid3D([17518,17287,17233,17069],0); -ELEMENTS[59691] = Fluid3D([17518,17287,17069,17566],0); -ELEMENTS[59692] = Fluid3D([17233,17518,17069,16931],0); -ELEMENTS[59693] = Fluid3D([17287,17233,17069,16718],0); -ELEMENTS[59694] = Fluid3D([17069,17233,16931,16738],0); -ELEMENTS[59695] = Fluid3D([16931,17069,16738,16781],0); -ELEMENTS[59696] = Fluid3D([17069,17233,16738,16718],0); -ELEMENTS[59697] = Fluid3D([16738,17069,16718,16781],0); -ELEMENTS[59698] = Fluid3D([8729,9489,9599,9612],0); -ELEMENTS[59699] = Fluid3D([4077,3979,4524,4479],0); -ELEMENTS[59700] = Fluid3D([17864,17584,17923,17705],0); -ELEMENTS[59701] = Fluid3D([15655,15124,15652,15630],0); -ELEMENTS[59702] = Fluid3D([2448,2357,2144,2346],0); -ELEMENTS[59703] = Fluid3D([12560,12657,12403,13102],0); -ELEMENTS[59704] = Fluid3D([12657,12403,13102,13614],0); -ELEMENTS[59705] = Fluid3D([12560,12657,13102,13790],0); -ELEMENTS[59706] = Fluid3D([12299,12024,13191,12710],0); -ELEMENTS[59707] = Fluid3D([13191,12299,12710,11812],0); -ELEMENTS[59708] = Fluid3D([17971,17707,18051,17858],0); -ELEMENTS[59709] = Fluid3D([17707,18051,17858,17822],0); -ELEMENTS[59710] = Fluid3D([14792,14668,15102,13973],0); -ELEMENTS[59711] = Fluid3D([2076,2022,2201,2279],0); -ELEMENTS[59712] = Fluid3D([17585,17698,17418,17277],0); -ELEMENTS[59713] = Fluid3D([17585,17698,17277,17847],0); -ELEMENTS[59714] = Fluid3D([13604,14181,13553,13175],0); -ELEMENTS[59715] = Fluid3D([9082,9875,8847,9279],0); -ELEMENTS[59716] = Fluid3D([1941,2027,1872,2122],0); -ELEMENTS[59717] = Fluid3D([11966,12251,13126,12932],0); -ELEMENTS[59718] = Fluid3D([12693,11618,12171,12529],0); -ELEMENTS[59719] = Fluid3D([17400,16970,17104,16968],0); -ELEMENTS[59720] = Fluid3D([17400,16970,16968,17270],0); -ELEMENTS[59721] = Fluid3D([16970,17104,16968,16631],0); -ELEMENTS[59722] = Fluid3D([16970,16968,17270,16837],0); -ELEMENTS[59723] = Fluid3D([4263,3825,3912,4170],0); -ELEMENTS[59724] = Fluid3D([14167,14660,14431,13722],0); -ELEMENTS[59725] = Fluid3D([14167,14660,13722,14386],0); -ELEMENTS[59726] = Fluid3D([16651,16823,16460,16005],0); -ELEMENTS[59727] = Fluid3D([8581,8289,9362,8752],0); -ELEMENTS[59728] = Fluid3D([10011,9122,9233,9457],0); -ELEMENTS[59729] = Fluid3D([10011,9122,9457,9900],0); -ELEMENTS[59730] = Fluid3D([9457,10011,9900,10836],0); -ELEMENTS[59731] = Fluid3D([1706,1606,1644,1705],0); -ELEMENTS[59732] = Fluid3D([3310,3109,3486,3607],0); -ELEMENTS[59733] = Fluid3D([17370,17465,17745,17340],0); -ELEMENTS[59734] = Fluid3D([17370,17465,17340,17042],0); -ELEMENTS[59735] = Fluid3D([4335,4834,4929,4814],0); -ELEMENTS[59736] = Fluid3D([4929,4335,4814,4430],0); -ELEMENTS[59737] = Fluid3D([4834,4929,4814,5329],0); -ELEMENTS[59738] = Fluid3D([4929,4814,5329,5543],0); -ELEMENTS[59739] = Fluid3D([2664,2772,2969,3077],0); -ELEMENTS[59740] = Fluid3D([16791,16267,16442,16250],0); -ELEMENTS[59741] = Fluid3D([16267,16442,16250,15869],0); -ELEMENTS[59742] = Fluid3D([16791,16267,16250,16631],0); -ELEMENTS[59743] = Fluid3D([16442,16791,16250,16657],0); -ELEMENTS[59744] = Fluid3D([16250,16442,16657,15885],0); -ELEMENTS[59745] = Fluid3D([16791,16250,16657,16578],0); -ELEMENTS[59746] = Fluid3D([16250,16657,16578,15851],0); -ELEMENTS[59747] = Fluid3D([16657,16791,16578,16920],0); -ELEMENTS[59748] = Fluid3D([16578,16657,16920,16885],0); -ELEMENTS[59749] = Fluid3D([16657,16920,16885,16962],0); -ELEMENTS[59750] = Fluid3D([16920,16578,16885,16803],0); -ELEMENTS[59751] = Fluid3D([16885,16920,16803,17259],0); -ELEMENTS[59752] = Fluid3D([16885,16657,16962,16470],0); -ELEMENTS[59753] = Fluid3D([16885,16657,16470,16332],0); -ELEMENTS[59754] = Fluid3D([16657,16962,16470,16442],0); -ELEMENTS[59755] = Fluid3D([16657,16962,16442,16791],0); -ELEMENTS[59756] = Fluid3D([16470,16657,16442,15885],0); -ELEMENTS[59757] = Fluid3D([16657,16962,16791,16920],0); -ELEMENTS[59758] = Fluid3D([16578,16657,16885,16332],0); -ELEMENTS[59759] = Fluid3D([16885,16920,17259,17321],0); -ELEMENTS[59760] = Fluid3D([16885,16920,17321,17245],0); -ELEMENTS[59761] = Fluid3D([16920,17259,17321,17245],0); -ELEMENTS[59762] = Fluid3D([16578,16657,16332,15851],0); -ELEMENTS[59763] = Fluid3D([16920,16885,16962,17245],0); -ELEMENTS[59764] = Fluid3D([16250,16267,15869,15641],0); -ELEMENTS[59765] = Fluid3D([4355,4885,4657,5065],0); -ELEMENTS[59766] = Fluid3D([12523,12380,11642,11049],0); -ELEMENTS[59767] = Fluid3D([2243,2092,2186,1939],0); -ELEMENTS[59768] = Fluid3D([15608,15883,15460,15295],0); -ELEMENTS[59769] = Fluid3D([13977,13796,14295,12764],0); -ELEMENTS[59770] = Fluid3D([12888,12765,11903,12515],0); -ELEMENTS[59771] = Fluid3D([8105,8920,9230,7861],0); -ELEMENTS[59772] = Fluid3D([11513,12328,11476,11436],0); -ELEMENTS[59773] = Fluid3D([12328,11476,11436,12309],0); -ELEMENTS[59774] = Fluid3D([11476,11436,12309,11466],0); -ELEMENTS[59775] = Fluid3D([5386,5795,5191,5516],0); -ELEMENTS[59776] = Fluid3D([6560,7228,7330,7233],0); -ELEMENTS[59777] = Fluid3D([18373,18266,18214,18078],0); -ELEMENTS[59778] = Fluid3D([16803,16885,16332,16578],0); -ELEMENTS[59779] = Fluid3D([18619,18594,18545,18547],0); -ELEMENTS[59780] = Fluid3D([10420,11526,11231,10854],0); -ELEMENTS[59781] = Fluid3D([11231,10420,10854,10123],0); -ELEMENTS[59782] = Fluid3D([2973,2659,3010,2936],0); -ELEMENTS[59783] = Fluid3D([3010,2973,2936,3383],0); -ELEMENTS[59784] = Fluid3D([3825,3429,3508,3878],0); -ELEMENTS[59785] = Fluid3D([17158,16847,16993,16627],0); -ELEMENTS[59786] = Fluid3D([17158,16847,16627,17016],0); -ELEMENTS[59787] = Fluid3D([16847,16993,16627,16653],0); -ELEMENTS[59788] = Fluid3D([16847,16627,17016,16688],0); -ELEMENTS[59789] = Fluid3D([15995,16376,16165,15725],0); -ELEMENTS[59790] = Fluid3D([2355,2137,2241,2453],0); -ELEMENTS[59791] = Fluid3D([17081,17386,17194,16932],0); -ELEMENTS[59792] = Fluid3D([5767,6245,6391,6102],0); -ELEMENTS[59793] = Fluid3D([10807,10680,11591,12014],0); -ELEMENTS[59794] = Fluid3D([10680,11591,12014,11757],0); -ELEMENTS[59795] = Fluid3D([16406,15819,16090,15812],0); -ELEMENTS[59796] = Fluid3D([15819,16090,15812,15447],0); -ELEMENTS[59797] = Fluid3D([16406,15819,15812,16169],0); -ELEMENTS[59798] = Fluid3D([2108,2212,2027,2232],0); -ELEMENTS[59799] = Fluid3D([2108,2212,2232,2237],0); -ELEMENTS[59800] = Fluid3D([2232,2108,2237,2220],0); -ELEMENTS[59801] = Fluid3D([2237,2232,2220,2365],0); -ELEMENTS[59802] = Fluid3D([2237,2232,2365,2403],0); -ELEMENTS[59803] = Fluid3D([2232,2365,2403,2401],0); -ELEMENTS[59804] = Fluid3D([2232,2220,2365,2122],0); -ELEMENTS[59805] = Fluid3D([2365,2232,2122,2027],0); -ELEMENTS[59806] = Fluid3D([2232,2220,2122,1941],0); -ELEMENTS[59807] = Fluid3D([2232,2122,2027,1941],0); -ELEMENTS[59808] = Fluid3D([2212,2027,2232,2403],0); -ELEMENTS[59809] = Fluid3D([2232,2212,2403,2237],0); -ELEMENTS[59810] = Fluid3D([2027,2108,2232,1941],0); -ELEMENTS[59811] = Fluid3D([2220,2365,2122,2318],0); -ELEMENTS[59812] = Fluid3D([2122,2220,2318,2006],0); -ELEMENTS[59813] = Fluid3D([2122,2220,2006,1941],0); -ELEMENTS[59814] = Fluid3D([2365,2232,2027,2130],0); -ELEMENTS[59815] = Fluid3D([18612,18540,18558,18511],0); -ELEMENTS[59816] = Fluid3D([18540,18558,18511,18465],0); -ELEMENTS[59817] = Fluid3D([18558,18612,18511,18559],0); -ELEMENTS[59818] = Fluid3D([18612,18511,18559,18539],0); -ELEMENTS[59819] = Fluid3D([18511,18559,18539,18445],0); -ELEMENTS[59820] = Fluid3D([18539,18511,18445,18397],0); -ELEMENTS[59821] = Fluid3D([18612,18511,18539,18540],0); -ELEMENTS[59822] = Fluid3D([18511,18445,18397,18220],0); -ELEMENTS[59823] = Fluid3D([18511,18558,18559,18438],0); -ELEMENTS[59824] = Fluid3D([18511,18539,18540,18397],0); -ELEMENTS[59825] = Fluid3D([18540,18511,18397,18465],0); -ELEMENTS[59826] = Fluid3D([18511,18558,18438,18465],0); -ELEMENTS[59827] = Fluid3D([18511,18559,18445,18220],0); -ELEMENTS[59828] = Fluid3D([4892,5146,4604,5159],0); -ELEMENTS[59829] = Fluid3D([16532,16762,16878,16160],0); -ELEMENTS[59830] = Fluid3D([6395,7149,6315,6626],0); -ELEMENTS[59831] = Fluid3D([6395,7149,6626,7262],0); -ELEMENTS[59832] = Fluid3D([6626,6395,7262,6494],0); -ELEMENTS[59833] = Fluid3D([2697,2504,2433,2771],0); -ELEMENTS[59834] = Fluid3D([14418,14124,14620,13780],0); -ELEMENTS[59835] = Fluid3D([12703,12906,12366,13136],0); -ELEMENTS[59836] = Fluid3D([12925,13616,12760,12311],0); -ELEMENTS[59837] = Fluid3D([10700,11418,10450,10990],0); -ELEMENTS[59838] = Fluid3D([18483,18353,18439,18185],0); -ELEMENTS[59839] = Fluid3D([15170,15207,15552,14634],0); -ELEMENTS[59840] = Fluid3D([13138,13116,13502,14124],0); -ELEMENTS[59841] = Fluid3D([14895,15078,14609,14369],0); -ELEMENTS[59842] = Fluid3D([2477,2756,2611,2998],0); -ELEMENTS[59843] = Fluid3D([15241,14790,14872,14696],0); -ELEMENTS[59844] = Fluid3D([14872,15241,14696,15076],0); -ELEMENTS[59845] = Fluid3D([11563,10654,10732,10619],0); -ELEMENTS[59846] = Fluid3D([11563,10654,10619,11513],0); -ELEMENTS[59847] = Fluid3D([10654,10619,11513,10040],0); -ELEMENTS[59848] = Fluid3D([10654,10619,10040,9814],0); -ELEMENTS[59849] = Fluid3D([10654,10732,10619,9814],0); -ELEMENTS[59850] = Fluid3D([16210,16249,15890,15826],0); -ELEMENTS[59851] = Fluid3D([2736,2838,3047,3210],0); -ELEMENTS[59852] = Fluid3D([3047,2736,3210,2960],0); -ELEMENTS[59853] = Fluid3D([2838,3047,3210,3160],0); -ELEMENTS[59854] = Fluid3D([3210,3047,2960,3314],0); -ELEMENTS[59855] = Fluid3D([3210,3047,3314,3277],0); -ELEMENTS[59856] = Fluid3D([3210,3047,3277,3563],0); -ELEMENTS[59857] = Fluid3D([3210,3047,3563,3160],0); -ELEMENTS[59858] = Fluid3D([3047,3563,3160,3470],0); -ELEMENTS[59859] = Fluid3D([15725,15180,15666,16165],0); -ELEMENTS[59860] = Fluid3D([3778,4220,4272,4150],0); -ELEMENTS[59861] = Fluid3D([17064,16974,16736,16500],0); -ELEMENTS[59862] = Fluid3D([8302,8359,9216,8771],0); -ELEMENTS[59863] = Fluid3D([15451,15660,16080,15303],0); -ELEMENTS[59864] = Fluid3D([10511,11233,11166,11350],0); -ELEMENTS[59865] = Fluid3D([18506,18379,18457,18364],0); -ELEMENTS[59866] = Fluid3D([18379,18457,18364,18270],0); -ELEMENTS[59867] = Fluid3D([18457,18506,18364,18328],0); -ELEMENTS[59868] = Fluid3D([18506,18364,18328,18223],0); -ELEMENTS[59869] = Fluid3D([18364,18328,18223,18270],0); -ELEMENTS[59870] = Fluid3D([18364,18328,18270,18457],0); -ELEMENTS[59871] = Fluid3D([18223,18364,18270,18379],0); -ELEMENTS[59872] = Fluid3D([18223,18364,18379,18506],0); -ELEMENTS[59873] = Fluid3D([18328,18223,18270,18037],0); -ELEMENTS[59874] = Fluid3D([18223,18270,18037,18325],0); -ELEMENTS[59875] = Fluid3D([1715,1809,1829,1873],0); -ELEMENTS[59876] = Fluid3D([1715,1809,1873,1698],0); -ELEMENTS[59877] = Fluid3D([15262,14833,15198,14374],0); -ELEMENTS[59878] = Fluid3D([9047,8416,9297,9354],0); -ELEMENTS[59879] = Fluid3D([8416,9297,9354,8664],0); -ELEMENTS[59880] = Fluid3D([2847,2962,2650,3015],0); -ELEMENTS[59881] = Fluid3D([2847,2962,3015,3207],0); -ELEMENTS[59882] = Fluid3D([2650,2847,3015,2812],0); -ELEMENTS[59883] = Fluid3D([3015,2847,3207,3061],0); -ELEMENTS[59884] = Fluid3D([2962,2650,3015,3159],0); -ELEMENTS[59885] = Fluid3D([2847,3015,2812,3061],0); -ELEMENTS[59886] = Fluid3D([13561,12563,12864,13430],0); -ELEMENTS[59887] = Fluid3D([13561,12563,13430,13286],0); -ELEMENTS[59888] = Fluid3D([13430,13561,13286,14217],0); -ELEMENTS[59889] = Fluid3D([13430,13561,14217,14538],0); -ELEMENTS[59890] = Fluid3D([14745,14228,14999,14508],0); -ELEMENTS[59891] = Fluid3D([14999,14745,14508,15101],0); -ELEMENTS[59892] = Fluid3D([14745,14508,15101,14028],0); -ELEMENTS[59893] = Fluid3D([14745,14508,14028,14228],0); -ELEMENTS[59894] = Fluid3D([14508,14028,14228,13750],0); -ELEMENTS[59895] = Fluid3D([14508,14028,13750,13749],0); -ELEMENTS[59896] = Fluid3D([14508,14028,13749,13952],0); -ELEMENTS[59897] = Fluid3D([14028,14745,14228,13916],0); -ELEMENTS[59898] = Fluid3D([14028,14745,13916,14459],0); -ELEMENTS[59899] = Fluid3D([14508,15101,14028,13952],0); -ELEMENTS[59900] = Fluid3D([14228,14028,13916,13360],0); -ELEMENTS[59901] = Fluid3D([14798,15308,14962,15338],0); -ELEMENTS[59902] = Fluid3D([15103,15356,15544,14932],0); -ELEMENTS[59903] = Fluid3D([15544,15103,14932,15337],0); -ELEMENTS[59904] = Fluid3D([5778,5422,5995,6008],0); -ELEMENTS[59905] = Fluid3D([8008,7187,7361,7429],0); -ELEMENTS[59906] = Fluid3D([7361,8008,7429,8179],0); -ELEMENTS[59907] = Fluid3D([17133,17055,17359,16904],0); -ELEMENTS[59908] = Fluid3D([17723,17886,17639,17610],0); -ELEMENTS[59909] = Fluid3D([15662,15554,15004,15260],0); -ELEMENTS[59910] = Fluid3D([15554,15004,15260,14912],0); -ELEMENTS[59911] = Fluid3D([15260,15554,14912,15471],0); -ELEMENTS[59912] = Fluid3D([15260,15554,15471,15748],0); -ELEMENTS[59913] = Fluid3D([15260,15554,15748,15741],0); -ELEMENTS[59914] = Fluid3D([15260,15554,15741,15662],0); -ELEMENTS[59915] = Fluid3D([15471,15260,15748,14825],0); -ELEMENTS[59916] = Fluid3D([6575,6677,7326,7344],0); -ELEMENTS[59917] = Fluid3D([6677,7326,7344,7024],0); -ELEMENTS[59918] = Fluid3D([6677,7326,7024,7272],0); -ELEMENTS[59919] = Fluid3D([6677,7326,7272,6921],0); -ELEMENTS[59920] = Fluid3D([7326,6575,7344,7446],0); -ELEMENTS[59921] = Fluid3D([7344,7326,7446,8257],0); -ELEMENTS[59922] = Fluid3D([7024,6677,7272,6388],0); -ELEMENTS[59923] = Fluid3D([6575,7344,7446,7236],0); -ELEMENTS[59924] = Fluid3D([10227,9254,9656,9596],0); -ELEMENTS[59925] = Fluid3D([15832,15743,16127,15439],0); -ELEMENTS[59926] = Fluid3D([16047,15663,15980,15476],0); -ELEMENTS[59927] = Fluid3D([15980,16047,15476,15898],0); -ELEMENTS[59928] = Fluid3D([3847,4317,4147,4591],0); -ELEMENTS[59929] = Fluid3D([13616,13493,12760,12902],0); -ELEMENTS[59930] = Fluid3D([18028,17797,17937,17595],0); -ELEMENTS[59931] = Fluid3D([1680,1606,1593,1681],0); -ELEMENTS[59932] = Fluid3D([13972,13037,13286,13408],0); -ELEMENTS[59933] = Fluid3D([18576,18558,18494,18438],0); -ELEMENTS[59934] = Fluid3D([18558,18494,18438,18465],0); -ELEMENTS[59935] = Fluid3D([15423,15389,15972,15551],0); -ELEMENTS[59936] = Fluid3D([16359,15972,16153,15423],0); -ELEMENTS[59937] = Fluid3D([4953,4725,5287,5107],0); -ELEMENTS[59938] = Fluid3D([4725,5287,5107,5078],0); -ELEMENTS[59939] = Fluid3D([4953,4725,5107,4417],0); -ELEMENTS[59940] = Fluid3D([5107,4725,5078,5103],0); -ELEMENTS[59941] = Fluid3D([5107,4725,5103,4654],0); -ELEMENTS[59942] = Fluid3D([5107,4725,4654,4417],0); -ELEMENTS[59943] = Fluid3D([5103,5107,4654,5174],0); -ELEMENTS[59944] = Fluid3D([10695,11798,11420,10875],0); -ELEMENTS[59945] = Fluid3D([9500,8595,8817,9854],0); -ELEMENTS[59946] = Fluid3D([18624,18611,18562,18548],0); -ELEMENTS[59947] = Fluid3D([18562,18624,18548,18502],0); -ELEMENTS[59948] = Fluid3D([18548,18562,18502,18378],0); -ELEMENTS[59949] = Fluid3D([18502,18548,18378,18412],0); -ELEMENTS[59950] = Fluid3D([18378,18502,18412,18452],0); -ELEMENTS[59951] = Fluid3D([18624,18548,18502,18553],0); -ELEMENTS[59952] = Fluid3D([18548,18502,18553,18412],0); -ELEMENTS[59953] = Fluid3D([18611,18562,18548,18526],0); -ELEMENTS[59954] = Fluid3D([18624,18611,18548,18658],0); -ELEMENTS[59955] = Fluid3D([18548,18611,18526,18598],0); -ELEMENTS[59956] = Fluid3D([18548,18611,18598,18658],0); -ELEMENTS[59957] = Fluid3D([18611,18526,18598,18646],0); -ELEMENTS[59958] = Fluid3D([18526,18548,18598,18412],0); -ELEMENTS[59959] = Fluid3D([18598,18611,18646,18658],0); -ELEMENTS[59960] = Fluid3D([18646,18598,18658,18618],0); -ELEMENTS[59961] = Fluid3D([18598,18658,18618,18548],0); -ELEMENTS[59962] = Fluid3D([18618,18598,18548,18543],0); -ELEMENTS[59963] = Fluid3D([18618,18598,18543,18601],0); -ELEMENTS[59964] = Fluid3D([18618,18598,18601,18646],0); -ELEMENTS[59965] = Fluid3D([18598,18601,18646,18526],0); -ELEMENTS[59966] = Fluid3D([18598,18543,18601,18475],0); -ELEMENTS[59967] = Fluid3D([18601,18598,18475,18526],0); -ELEMENTS[59968] = Fluid3D([18598,18475,18526,18412],0); -ELEMENTS[59969] = Fluid3D([18548,18378,18412,18421],0); -ELEMENTS[59970] = Fluid3D([14370,13756,13646,14763],0); -ELEMENTS[59971] = Fluid3D([17822,17928,18142,18046],0); -ELEMENTS[59972] = Fluid3D([2509,2729,2781,2988],0); -ELEMENTS[59973] = Fluid3D([2729,2781,2988,3020],0); -ELEMENTS[59974] = Fluid3D([2988,2729,3020,2981],0); -ELEMENTS[59975] = Fluid3D([8338,7804,7591,7808],0); -ELEMENTS[59976] = Fluid3D([18136,17926,18080,17874],0); -ELEMENTS[59977] = Fluid3D([3597,3954,3797,3805],0); -ELEMENTS[59978] = Fluid3D([11067,11649,10526,11076],0); -ELEMENTS[59979] = Fluid3D([2491,2682,2415,2813],0); -ELEMENTS[59980] = Fluid3D([2491,2682,2813,2761],0); -ELEMENTS[59981] = Fluid3D([2682,2415,2813,2605],0); -ELEMENTS[59982] = Fluid3D([2682,2813,2761,3038],0); -ELEMENTS[59983] = Fluid3D([2682,2813,3038,3214],0); -ELEMENTS[59984] = Fluid3D([2813,2682,2605,2888],0); -ELEMENTS[59985] = Fluid3D([2813,2761,3038,2695],0); -ELEMENTS[59986] = Fluid3D([2761,3038,2695,2851],0); -ELEMENTS[59987] = Fluid3D([18482,18563,18560,18476],0); -ELEMENTS[59988] = Fluid3D([15561,16161,16031,15535],0); -ELEMENTS[59989] = Fluid3D([16031,15561,15535,15414],0); -ELEMENTS[59990] = Fluid3D([15561,16161,15535,15732],0); -ELEMENTS[59991] = Fluid3D([15561,15535,15414,14893],0); -ELEMENTS[59992] = Fluid3D([15535,15561,15732,15065],0); -ELEMENTS[59993] = Fluid3D([4920,4861,4426,5050],0); -ELEMENTS[59994] = Fluid3D([17991,17837,17761,17450],0); -ELEMENTS[59995] = Fluid3D([4677,4091,4497,4737],0); -ELEMENTS[59996] = Fluid3D([4497,4677,4737,5133],0); -ELEMENTS[59997] = Fluid3D([16966,17169,16858,16732],0); -ELEMENTS[59998] = Fluid3D([2214,2200,2222,2009],0); -ELEMENTS[59999] = Fluid3D([7309,7811,7000,8182],0); -ELEMENTS[60000] = Fluid3D([5809,5656,5637,6583],0); -ELEMENTS[60001] = Fluid3D([5708,5651,5081,5354],0); -ELEMENTS[60002] = Fluid3D([3435,3084,3376,3550],0); -ELEMENTS[60003] = Fluid3D([3435,3084,3550,3152],0); -ELEMENTS[60004] = Fluid3D([3550,3435,3152,3523],0); -ELEMENTS[60005] = Fluid3D([9903,9480,9471,9045],0); -ELEMENTS[60006] = Fluid3D([14893,15065,15561,15535],0); -ELEMENTS[60007] = Fluid3D([4103,3989,4482,4000],0); -ELEMENTS[60008] = Fluid3D([6465,6928,7292,7198],0); -ELEMENTS[60009] = Fluid3D([14764,14881,15062,15470],0); -ELEMENTS[60010] = Fluid3D([18251,17984,18084,18151],0); -ELEMENTS[60011] = Fluid3D([18084,18251,18151,18272],0); -ELEMENTS[60012] = Fluid3D([18251,17984,18151,18164],0); -ELEMENTS[60013] = Fluid3D([14417,15246,14980,14975],0); -ELEMENTS[60014] = Fluid3D([1992,1848,1874,2047],0); -ELEMENTS[60015] = Fluid3D([8884,8612,7979,8350],0); -ELEMENTS[60016] = Fluid3D([17158,17455,17330,17285],0); -ELEMENTS[60017] = Fluid3D([15440,14995,15185,14720],0); -ELEMENTS[60018] = Fluid3D([15010,14759,14102,14398],0); -ELEMENTS[60019] = Fluid3D([16828,17030,16529,16877],0); -ELEMENTS[60020] = Fluid3D([15493,15729,16166,15935],0); -ELEMENTS[60021] = Fluid3D([1907,1814,1952,2046],0); -ELEMENTS[60022] = Fluid3D([1952,1907,2046,2062],0); -ELEMENTS[60023] = Fluid3D([18637,18644,18578,18583],0); -ELEMENTS[60024] = Fluid3D([13706,14308,13497,13552],0); -ELEMENTS[60025] = Fluid3D([13706,14308,13552,13913],0); -ELEMENTS[60026] = Fluid3D([13552,13706,13913,12636],0); -ELEMENTS[60027] = Fluid3D([14308,13552,13913,13577],0); -ELEMENTS[60028] = Fluid3D([13552,13913,13577,12929],0); -ELEMENTS[60029] = Fluid3D([13577,13552,12929,13571],0); -ELEMENTS[60030] = Fluid3D([13577,13552,13571,14308],0); -ELEMENTS[60031] = Fluid3D([13552,12929,13571,13497],0); -ELEMENTS[60032] = Fluid3D([12929,13577,13571,13428],0); -ELEMENTS[60033] = Fluid3D([13552,13913,12929,12636],0); -ELEMENTS[60034] = Fluid3D([12929,13552,12636,13497],0); -ELEMENTS[60035] = Fluid3D([13571,13552,13497,14308],0); -ELEMENTS[60036] = Fluid3D([13497,13706,13552,12636],0); -ELEMENTS[60037] = Fluid3D([13577,13571,13428,14300],0); -ELEMENTS[60038] = Fluid3D([9604,8664,8979,9950],0); -ELEMENTS[60039] = Fluid3D([18521,18409,18497,18355],0); -ELEMENTS[60040] = Fluid3D([10003,9058,9673,9308],0); -ELEMENTS[60041] = Fluid3D([3482,3175,3445,2954],0); -ELEMENTS[60042] = Fluid3D([11826,11468,11356,10535],0); -ELEMENTS[60043] = Fluid3D([6584,6022,6693,7146],0); -ELEMENTS[60044] = Fluid3D([6144,5444,6075,5811],0); -ELEMENTS[60045] = Fluid3D([17695,17422,17617,17215],0); -ELEMENTS[60046] = Fluid3D([16569,16952,16448,16489],0); -ELEMENTS[60047] = Fluid3D([16448,16569,16489,16084],0); -ELEMENTS[60048] = Fluid3D([16569,16952,16489,16613],0); -ELEMENTS[60049] = Fluid3D([16952,16448,16489,16686],0); -ELEMENTS[60050] = Fluid3D([16489,16448,16084,16686],0); -ELEMENTS[60051] = Fluid3D([16084,16489,16686,16613],0); -ELEMENTS[60052] = Fluid3D([16084,16489,16613,16134],0); -ELEMENTS[60053] = Fluid3D([16489,16686,16613,16952],0); -ELEMENTS[60054] = Fluid3D([16084,16489,16134,16569],0); -ELEMENTS[60055] = Fluid3D([16489,16134,16569,16613],0); -ELEMENTS[60056] = Fluid3D([16748,16618,16189,16799],0); -ELEMENTS[60057] = Fluid3D([18209,18339,18170,18108],0); -ELEMENTS[60058] = Fluid3D([11719,10750,11470,12107],0); -ELEMENTS[60059] = Fluid3D([6395,5785,6494,6006],0); -ELEMENTS[60060] = Fluid3D([13115,12885,13395,12107],0); -ELEMENTS[60061] = Fluid3D([13087,12197,12399,12357],0); -ELEMENTS[60062] = Fluid3D([16737,16681,17000,16358],0); -ELEMENTS[60063] = Fluid3D([4788,5274,5307,5319],0); -ELEMENTS[60064] = Fluid3D([4788,5274,5319,4759],0); -ELEMENTS[60065] = Fluid3D([5274,5319,4759,5400],0); -ELEMENTS[60066] = Fluid3D([5274,5319,5400,5976],0); -ELEMENTS[60067] = Fluid3D([4759,5274,5400,5252],0); -ELEMENTS[60068] = Fluid3D([5274,5319,5976,5307],0); -ELEMENTS[60069] = Fluid3D([5319,4759,5400,5028],0); -ELEMENTS[60070] = Fluid3D([5319,4788,4759,4653],0); -ELEMENTS[60071] = Fluid3D([17110,17193,17522,17201],0); -ELEMENTS[60072] = Fluid3D([18469,18538,18435,18421],0); -ELEMENTS[60073] = Fluid3D([12018,11501,12646,11954],0); -ELEMENTS[60074] = Fluid3D([8709,9641,9280,9925],0); -ELEMENTS[60075] = Fluid3D([9641,9280,9925,10244],0); -ELEMENTS[60076] = Fluid3D([9280,9925,10244,10364],0); -ELEMENTS[60077] = Fluid3D([9280,9925,10364,8979],0); -ELEMENTS[60078] = Fluid3D([9507,8583,8924,8519],0); -ELEMENTS[60079] = Fluid3D([9184,8642,8268,9226],0); -ELEMENTS[60080] = Fluid3D([18256,18066,18181,18005],0); -ELEMENTS[60081] = Fluid3D([15782,16248,15589,15746],0); -ELEMENTS[60082] = Fluid3D([15589,15782,15746,15050],0); -ELEMENTS[60083] = Fluid3D([15782,16248,15746,16402],0); -ELEMENTS[60084] = Fluid3D([14064,13679,14175,13429],0); -ELEMENTS[60085] = Fluid3D([13679,14175,13429,13321],0); -ELEMENTS[60086] = Fluid3D([14175,14064,13429,14532],0); -ELEMENTS[60087] = Fluid3D([14064,13679,13429,12901],0); -ELEMENTS[60088] = Fluid3D([13679,13429,12901,12887],0); -ELEMENTS[60089] = Fluid3D([3300,3020,2981,3331],0); -ELEMENTS[60090] = Fluid3D([15068,14782,14605,13866],0); -ELEMENTS[60091] = Fluid3D([3125,3114,3573,3415],0); -ELEMENTS[60092] = Fluid3D([12309,13114,12316,11811],0); -ELEMENTS[60093] = Fluid3D([18443,18545,18512,18460],0); -ELEMENTS[60094] = Fluid3D([11779,12032,12790,12476],0); -ELEMENTS[60095] = Fluid3D([18539,18605,18612,18540],0); -ELEMENTS[60096] = Fluid3D([17413,17392,17142,17102],0); -ELEMENTS[60097] = Fluid3D([16837,16461,16970,16968],0); -ELEMENTS[60098] = Fluid3D([16997,16797,16663,16498],0); -ELEMENTS[60099] = Fluid3D([17015,17153,16841,16457],0); -ELEMENTS[60100] = Fluid3D([11893,12763,12527,12478],0); -ELEMENTS[60101] = Fluid3D([17376,17106,17366,17025],0); -ELEMENTS[60102] = Fluid3D([17366,17376,17025,17621],0); -ELEMENTS[60103] = Fluid3D([17106,17366,17025,16912],0); -ELEMENTS[60104] = Fluid3D([17366,17025,16912,16773],0); -ELEMENTS[60105] = Fluid3D([17025,16912,16773,16373],0); -ELEMENTS[60106] = Fluid3D([17025,17106,16912,16366],0); -ELEMENTS[60107] = Fluid3D([17106,17366,16912,17092],0); -ELEMENTS[60108] = Fluid3D([17376,17106,17025,16910],0); -ELEMENTS[60109] = Fluid3D([2058,2144,2254,2211],0); -ELEMENTS[60110] = Fluid3D([16829,17112,16639,16784],0); -ELEMENTS[60111] = Fluid3D([2497,2349,2595,2651],0); -ELEMENTS[60112] = Fluid3D([4722,4189,4688,4363],0); -ELEMENTS[60113] = Fluid3D([18150,18028,17937,17853],0); -ELEMENTS[60114] = Fluid3D([18150,18028,17853,17940],0); -ELEMENTS[60115] = Fluid3D([17853,18150,17940,17834],0); -ELEMENTS[60116] = Fluid3D([18028,17853,17940,17950],0); -ELEMENTS[60117] = Fluid3D([17853,17940,17950,17595],0); -ELEMENTS[60118] = Fluid3D([17853,17940,17595,17694],0); -ELEMENTS[60119] = Fluid3D([17853,17940,17694,17834],0); -ELEMENTS[60120] = Fluid3D([17694,17853,17834,17378],0); -ELEMENTS[60121] = Fluid3D([17595,17853,17694,17378],0); -ELEMENTS[60122] = Fluid3D([17834,17694,17378,17710],0); -ELEMENTS[60123] = Fluid3D([17834,17694,17710,17940],0); -ELEMENTS[60124] = Fluid3D([18028,17853,17950,17595],0); -ELEMENTS[60125] = Fluid3D([17694,17710,17940,17595],0); -ELEMENTS[60126] = Fluid3D([17694,17378,17710,17595],0); -ELEMENTS[60127] = Fluid3D([17940,18028,17950,18150],0); -ELEMENTS[60128] = Fluid3D([17937,18150,17853,18066],0); -ELEMENTS[60129] = Fluid3D([18028,17937,17853,17595],0); -ELEMENTS[60130] = Fluid3D([16269,16026,16391,15985],0); -ELEMENTS[60131] = Fluid3D([1659,1756,1680,1828],0); -ELEMENTS[60132] = Fluid3D([9764,10779,10702,9892],0); -ELEMENTS[60133] = Fluid3D([9509,9917,10719,10737],0); -ELEMENTS[60134] = Fluid3D([4781,4394,4908,4442],0); -ELEMENTS[60135] = Fluid3D([4781,4394,4442,4310],0); -ELEMENTS[60136] = Fluid3D([4394,4908,4442,4498],0); -ELEMENTS[60137] = Fluid3D([4908,4781,4442,5334],0); -ELEMENTS[60138] = Fluid3D([11694,11484,11056,10428],0); -ELEMENTS[60139] = Fluid3D([11420,12150,11069,11249],0); -ELEMENTS[60140] = Fluid3D([18589,18641,18624,18565],0); -ELEMENTS[60141] = Fluid3D([15285,14852,15546,14769],0); -ELEMENTS[60142] = Fluid3D([17665,17888,17871,17514],0); -ELEMENTS[60143] = Fluid3D([2955,2989,3271,3140],0); -ELEMENTS[60144] = Fluid3D([15169,14649,14476,14586],0); -ELEMENTS[60145] = Fluid3D([16127,16216,15832,15860],0); -ELEMENTS[60146] = Fluid3D([16127,16216,15860,16480],0); -ELEMENTS[60147] = Fluid3D([16216,15860,16480,16566],0); -ELEMENTS[60148] = Fluid3D([16216,15832,15860,15937],0); -ELEMENTS[60149] = Fluid3D([16216,15860,16566,15875],0); -ELEMENTS[60150] = Fluid3D([16216,15860,15875,15937],0); -ELEMENTS[60151] = Fluid3D([4855,4345,4589,4419],0); -ELEMENTS[60152] = Fluid3D([9118,10002,9905,9794],0); -ELEMENTS[60153] = Fluid3D([9118,10002,9794,9993],0); -ELEMENTS[60154] = Fluid3D([10002,9794,9993,10636],0); -ELEMENTS[60155] = Fluid3D([10002,9794,10636,9905],0); -ELEMENTS[60156] = Fluid3D([10636,10002,9905,10456],0); -ELEMENTS[60157] = Fluid3D([10636,10002,10456,9959],0); -ELEMENTS[60158] = Fluid3D([10002,9905,10456,9265],0); -ELEMENTS[60159] = Fluid3D([10456,10002,9265,9959],0); -ELEMENTS[60160] = Fluid3D([9993,10002,10636,10594],0); -ELEMENTS[60161] = Fluid3D([10002,10636,10594,9959],0); -ELEMENTS[60162] = Fluid3D([9794,9993,10636,11038],0); -ELEMENTS[60163] = Fluid3D([17532,17619,17875,17731],0); -ELEMENTS[60164] = Fluid3D([17532,17619,17731,17236],0); -ELEMENTS[60165] = Fluid3D([17875,17532,17731,17587],0); -ELEMENTS[60166] = Fluid3D([12031,11634,11041,12193],0); -ELEMENTS[60167] = Fluid3D([8818,9184,8268,9226],0); -ELEMENTS[60168] = Fluid3D([13417,13918,13751,12967],0); -ELEMENTS[60169] = Fluid3D([13751,13417,12967,13242],0); -ELEMENTS[60170] = Fluid3D([15785,16048,16168,15763],0); -ELEMENTS[60171] = Fluid3D([3959,3535,3632,3523],0); -ELEMENTS[60172] = Fluid3D([18517,18481,18568,18370],0); -ELEMENTS[60173] = Fluid3D([7379,7624,6816,7720],0); -ELEMENTS[60174] = Fluid3D([7379,7624,7720,8312],0); -ELEMENTS[60175] = Fluid3D([7624,6816,7720,7373],0); -ELEMENTS[60176] = Fluid3D([6816,7720,7373,7502],0); -ELEMENTS[60177] = Fluid3D([7720,7373,7502,7936],0); -ELEMENTS[60178] = Fluid3D([7720,7373,7936,7624],0); -ELEMENTS[60179] = Fluid3D([6816,7379,7720,6581],0); -ELEMENTS[60180] = Fluid3D([7720,7379,8312,7502],0); -ELEMENTS[60181] = Fluid3D([7720,7379,7502,6581],0); -ELEMENTS[60182] = Fluid3D([8312,7720,7502,8337],0); -ELEMENTS[60183] = Fluid3D([7720,7502,8337,7936],0); -ELEMENTS[60184] = Fluid3D([8312,7720,8337,7624],0); -ELEMENTS[60185] = Fluid3D([8337,7720,7936,7624],0); -ELEMENTS[60186] = Fluid3D([6816,7720,7502,6581],0); -ELEMENTS[60187] = Fluid3D([12151,12632,12574,11731],0); -ELEMENTS[60188] = Fluid3D([12151,12632,11731,12221],0); -ELEMENTS[60189] = Fluid3D([12632,11731,12221,12710],0); -ELEMENTS[60190] = Fluid3D([11731,12151,12221,11255],0); -ELEMENTS[60191] = Fluid3D([11731,12151,11255,11579],0); -ELEMENTS[60192] = Fluid3D([12202,12386,13171,13126],0); -ELEMENTS[60193] = Fluid3D([18351,18184,18401,18212],0); -ELEMENTS[60194] = Fluid3D([18300,18255,18126,17969],0); -ELEMENTS[60195] = Fluid3D([4430,3895,4335,4372],0); -ELEMENTS[60196] = Fluid3D([15799,16181,16027,15755],0); -ELEMENTS[60197] = Fluid3D([5668,5287,5078,5657],0); -ELEMENTS[60198] = Fluid3D([17339,17094,17280,17639],0); -ELEMENTS[60199] = Fluid3D([9814,8967,9026,8548],0); -ELEMENTS[60200] = Fluid3D([8967,9026,8548,8186],0); -ELEMENTS[60201] = Fluid3D([9026,8548,8186,8285],0); -ELEMENTS[60202] = Fluid3D([17787,17441,17884,17593],0); -ELEMENTS[60203] = Fluid3D([13699,13949,12756,13276],0); -ELEMENTS[60204] = Fluid3D([2322,2182,2400,2450],0); -ELEMENTS[60205] = Fluid3D([2182,2400,2450,2493],0); -ELEMENTS[60206] = Fluid3D([2400,2322,2450,2683],0); -ELEMENTS[60207] = Fluid3D([2450,2400,2683,2718],0); -ELEMENTS[60208] = Fluid3D([2322,2182,2450,2379],0); -ELEMENTS[60209] = Fluid3D([6714,7249,6437,7497],0); -ELEMENTS[60210] = Fluid3D([7249,6437,7497,6992],0); -ELEMENTS[60211] = Fluid3D([12453,13086,12172,12916],0); -ELEMENTS[60212] = Fluid3D([11375,11011,11999,11995],0); -ELEMENTS[60213] = Fluid3D([11011,11999,11995,11650],0); -ELEMENTS[60214] = Fluid3D([18630,18568,18618,18553],0); -ELEMENTS[60215] = Fluid3D([18568,18618,18553,18543],0); -ELEMENTS[60216] = Fluid3D([18630,18568,18553,18595],0); -ELEMENTS[60217] = Fluid3D([18618,18630,18553,18624],0); -ELEMENTS[60218] = Fluid3D([18553,18568,18543,18370],0); -ELEMENTS[60219] = Fluid3D([18568,18553,18595,18452],0); -ELEMENTS[60220] = Fluid3D([2066,2094,1939,2243],0); -ELEMENTS[60221] = Fluid3D([2066,2094,2243,2245],0); -ELEMENTS[60222] = Fluid3D([2094,2243,2245,2276],0); -ELEMENTS[60223] = Fluid3D([15623,15512,15206,14936],0); -ELEMENTS[60224] = Fluid3D([5027,4498,4632,4712],0); -ELEMENTS[60225] = Fluid3D([4632,5027,4712,4928],0); -ELEMENTS[60226] = Fluid3D([5027,4498,4712,4871],0); -ELEMENTS[60227] = Fluid3D([4712,5027,4871,5084],0); -ELEMENTS[60228] = Fluid3D([5027,4712,4928,5084],0); -ELEMENTS[60229] = Fluid3D([4871,4712,5084,4471],0); -ELEMENTS[60230] = Fluid3D([4871,4712,4471,4131],0); -ELEMENTS[60231] = Fluid3D([4712,5084,4471,4928],0); -ELEMENTS[60232] = Fluid3D([4498,4632,4712,4131],0); -ELEMENTS[60233] = Fluid3D([4712,4498,4131,4871],0); -ELEMENTS[60234] = Fluid3D([11418,11190,10450,11862],0); -ELEMENTS[60235] = Fluid3D([18064,17881,17862,17775],0); -ELEMENTS[60236] = Fluid3D([17862,18064,17775,18043],0); -ELEMENTS[60237] = Fluid3D([18274,18360,18190,18004],0); -ELEMENTS[60238] = Fluid3D([4784,4274,4565,5040],0); -ELEMENTS[60239] = Fluid3D([13278,13726,14236,13292],0); -ELEMENTS[60240] = Fluid3D([13278,13726,13292,12722],0); -ELEMENTS[60241] = Fluid3D([13292,13278,12722,12336],0); -ELEMENTS[60242] = Fluid3D([12722,13292,12336,13452],0); -ELEMENTS[60243] = Fluid3D([13977,13678,13486,12823],0); -ELEMENTS[60244] = Fluid3D([7700,7044,7816,7286],0); -ELEMENTS[60245] = Fluid3D([4562,4469,4980,5335],0); -ELEMENTS[60246] = Fluid3D([17766,17518,17717,17377],0); -ELEMENTS[60247] = Fluid3D([17766,17518,17377,17566],0); -ELEMENTS[60248] = Fluid3D([4430,3979,3895,3967],0); -ELEMENTS[60249] = Fluid3D([3979,3895,3967,3504],0); -ELEMENTS[60250] = Fluid3D([3967,3979,3504,3595],0); -ELEMENTS[60251] = Fluid3D([3967,3979,3595,4077],0); -ELEMENTS[60252] = Fluid3D([3967,3979,4077,4479],0); -ELEMENTS[60253] = Fluid3D([3967,3979,4479,4430],0); -ELEMENTS[60254] = Fluid3D([3393,3012,3192,3356],0); -ELEMENTS[60255] = Fluid3D([3012,3192,3356,2853],0); -ELEMENTS[60256] = Fluid3D([3192,3393,3356,3589],0); -ELEMENTS[60257] = Fluid3D([3192,3356,2853,3274],0); -ELEMENTS[60258] = Fluid3D([3192,3356,3274,3723],0); -ELEMENTS[60259] = Fluid3D([3356,3192,3589,3723],0); -ELEMENTS[60260] = Fluid3D([5277,4740,5251,4536],0); -ELEMENTS[60261] = Fluid3D([5277,4740,4536,4708],0); -ELEMENTS[60262] = Fluid3D([6632,7453,7186,6542],0); -ELEMENTS[60263] = Fluid3D([9791,10319,9331,9687],0); -ELEMENTS[60264] = Fluid3D([9331,9791,9687,8834],0); -ELEMENTS[60265] = Fluid3D([9791,9687,8834,9284],0); -ELEMENTS[60266] = Fluid3D([9687,9331,8834,8418],0); -ELEMENTS[60267] = Fluid3D([2273,2529,2374,2721],0); -ELEMENTS[60268] = Fluid3D([13299,12941,13439,12541],0); -ELEMENTS[60269] = Fluid3D([15102,14668,14993,14384],0); -ELEMENTS[60270] = Fluid3D([14993,15102,14384,14627],0); -ELEMENTS[60271] = Fluid3D([15102,14384,14627,13973],0); -ELEMENTS[60272] = Fluid3D([14384,14627,13973,13840],0); -ELEMENTS[60273] = Fluid3D([13973,14384,13840,14335],0); -ELEMENTS[60274] = Fluid3D([14384,13840,14335,14627],0); -ELEMENTS[60275] = Fluid3D([13973,14384,14335,14668],0); -ELEMENTS[60276] = Fluid3D([13973,14384,14668,15102],0); -ELEMENTS[60277] = Fluid3D([14668,14993,14384,14335],0); -ELEMENTS[60278] = Fluid3D([14993,14384,14335,15012],0); -ELEMENTS[60279] = Fluid3D([14335,14993,15012,14913],0); -ELEMENTS[60280] = Fluid3D([14384,14335,15012,14627],0); -ELEMENTS[60281] = Fluid3D([14993,14384,15012,14627],0); -ELEMENTS[60282] = Fluid3D([5191,5032,4645,5140],0); -ELEMENTS[60283] = Fluid3D([4645,5191,5140,4815],0); -ELEMENTS[60284] = Fluid3D([2889,2694,2936,2642],0); -ELEMENTS[60285] = Fluid3D([15902,15940,16262,15615],0); -ELEMENTS[60286] = Fluid3D([15902,15940,15615,15290],0); -ELEMENTS[60287] = Fluid3D([15615,15902,15290,15393],0); -ELEMENTS[60288] = Fluid3D([15290,15615,15393,15297],0); -ELEMENTS[60289] = Fluid3D([15615,15393,15297,15879],0); -ELEMENTS[60290] = Fluid3D([15615,15393,15879,15902],0); -ELEMENTS[60291] = Fluid3D([15297,15615,15879,16262],0); -ELEMENTS[60292] = Fluid3D([15615,15879,16262,15902],0); -ELEMENTS[60293] = Fluid3D([15290,15615,15297,15940],0); -ELEMENTS[60294] = Fluid3D([15940,16262,15615,15297],0); -ELEMENTS[60295] = Fluid3D([9067,9516,10145,9357],0); -ELEMENTS[60296] = Fluid3D([4092,4357,4604,4922],0); -ELEMENTS[60297] = Fluid3D([3886,3464,3684,3965],0); -ELEMENTS[60298] = Fluid3D([16953,16899,17190,16508],0); -ELEMENTS[60299] = Fluid3D([15096,14986,14258,14645],0); -ELEMENTS[60300] = Fluid3D([9180,8495,8058,8616],0); -ELEMENTS[60301] = Fluid3D([8058,9180,8616,9086],0); -ELEMENTS[60302] = Fluid3D([2974,3011,2660,2931],0); -ELEMENTS[60303] = Fluid3D([10853,10171,10597,10426],0); -ELEMENTS[60304] = Fluid3D([10490,11137,10136,10326],0); -ELEMENTS[60305] = Fluid3D([5008,5386,4815,5316],0); -ELEMENTS[60306] = Fluid3D([14197,14473,14690,13922],0); -ELEMENTS[60307] = Fluid3D([14690,14197,13922,13813],0); -ELEMENTS[60308] = Fluid3D([14906,15361,15190,14231],0); -ELEMENTS[60309] = Fluid3D([8015,8729,8835,9042],0); -ELEMENTS[60310] = Fluid3D([8729,8835,9042,9836],0); -ELEMENTS[60311] = Fluid3D([8835,9042,9836,9299],0); -ELEMENTS[60312] = Fluid3D([18175,18317,18341,18075],0); -ELEMENTS[60313] = Fluid3D([15924,15618,15270,15309],0); -ELEMENTS[60314] = Fluid3D([14914,14796,14216,15333],0); -ELEMENTS[60315] = Fluid3D([2037,2143,2258,2289],0); -ELEMENTS[60316] = Fluid3D([4439,4445,4092,4604],0); -ELEMENTS[60317] = Fluid3D([18384,18245,18265,18254],0); -ELEMENTS[60318] = Fluid3D([18384,18245,18254,18372],0); -ELEMENTS[60319] = Fluid3D([18254,18384,18372,18490],0); -ELEMENTS[60320] = Fluid3D([18254,18384,18490,18500],0); -ELEMENTS[60321] = Fluid3D([18254,18384,18500,18281],0); -ELEMENTS[60322] = Fluid3D([18254,18384,18281,18265],0); -ELEMENTS[60323] = Fluid3D([3230,2888,2985,3214],0); -ELEMENTS[60324] = Fluid3D([2888,2985,3214,2682],0); -ELEMENTS[60325] = Fluid3D([1987,1922,2076,2166],0); -ELEMENTS[60326] = Fluid3D([1922,2076,2166,2022],0); -ELEMENTS[60327] = Fluid3D([2076,1987,2166,2253],0); -ELEMENTS[60328] = Fluid3D([2166,2076,2253,2480],0); -ELEMENTS[60329] = Fluid3D([2076,2166,2022,2279],0); -ELEMENTS[60330] = Fluid3D([15952,15293,15738,15692],0); -ELEMENTS[60331] = Fluid3D([10354,11266,11195,11736],0); -ELEMENTS[60332] = Fluid3D([6989,6245,6830,7377],0); -ELEMENTS[60333] = Fluid3D([6830,6989,7377,7619],0); -ELEMENTS[60334] = Fluid3D([6989,7377,7619,7773],0); -ELEMENTS[60335] = Fluid3D([7082,6670,7514,7278],0); -ELEMENTS[60336] = Fluid3D([7082,6670,7278,6566],0); -ELEMENTS[60337] = Fluid3D([4615,5153,4916,5043],0); -ELEMENTS[60338] = Fluid3D([4916,4615,5043,4381],0); -ELEMENTS[60339] = Fluid3D([11357,11469,11827,10536],0); -ELEMENTS[60340] = Fluid3D([16663,16878,16997,16555],0); -ELEMENTS[60341] = Fluid3D([8805,8876,9764,9091],0); -ELEMENTS[60342] = Fluid3D([8252,8014,7852,7260],0); -ELEMENTS[60343] = Fluid3D([9058,8753,9673,9308],0); -ELEMENTS[60344] = Fluid3D([9058,8753,9308,8156],0); -ELEMENTS[60345] = Fluid3D([9308,9058,8156,8468],0); -ELEMENTS[60346] = Fluid3D([15761,15416,15809,16290],0); -ELEMENTS[60347] = Fluid3D([2022,2132,2201,2279],0); -ELEMENTS[60348] = Fluid3D([13931,14385,14328,13409],0); -ELEMENTS[60349] = Fluid3D([14328,13931,13409,13865],0); -ELEMENTS[60350] = Fluid3D([17639,17561,17368,17290],0); -ELEMENTS[60351] = Fluid3D([17561,17368,17290,17266],0); -ELEMENTS[60352] = Fluid3D([17290,17561,17266,17482],0); -ELEMENTS[60353] = Fluid3D([17290,17561,17482,17742],0); -ELEMENTS[60354] = Fluid3D([17368,17290,17266,16943],0); -ELEMENTS[60355] = Fluid3D([17639,17561,17290,17480],0); -ELEMENTS[60356] = Fluid3D([17561,17290,17480,17742],0); -ELEMENTS[60357] = Fluid3D([17266,17290,17482,16913],0); -ELEMENTS[60358] = Fluid3D([17266,17290,16913,16943],0); -ELEMENTS[60359] = Fluid3D([17290,16913,16943,17033],0); -ELEMENTS[60360] = Fluid3D([18613,18542,18629,18518],0); -ELEMENTS[60361] = Fluid3D([12492,13505,13166,13125],0); -ELEMENTS[60362] = Fluid3D([2777,2738,2511,2957],0); -ELEMENTS[60363] = Fluid3D([14083,14467,13836,14907],0); -ELEMENTS[60364] = Fluid3D([13836,14083,14907,14643],0); -ELEMENTS[60365] = Fluid3D([14726,14431,14922,14161],0); -ELEMENTS[60366] = Fluid3D([14922,14726,14161,15185],0); -ELEMENTS[60367] = Fluid3D([14113,14609,14317,13659],0); -ELEMENTS[60368] = Fluid3D([14238,14860,14952,14822],0); -ELEMENTS[60369] = Fluid3D([15270,15597,15924,15071],0); -ELEMENTS[60370] = Fluid3D([3714,3900,4162,4248],0); -ELEMENTS[60371] = Fluid3D([15607,15375,15799,14983],0); -ELEMENTS[60372] = Fluid3D([16962,16442,16639,16470],0); -ELEMENTS[60373] = Fluid3D([13049,12167,12787,12231],0); -ELEMENTS[60374] = Fluid3D([13950,13086,13344,12916],0); -ELEMENTS[60375] = Fluid3D([17883,17632,17771,17389],0); -ELEMENTS[60376] = Fluid3D([5799,6420,6293,5702],0); -ELEMENTS[60377] = Fluid3D([5799,6420,5702,5920],0); -ELEMENTS[60378] = Fluid3D([5702,5799,5920,5334],0); -ELEMENTS[60379] = Fluid3D([4919,5467,5070,5882],0); -ELEMENTS[60380] = Fluid3D([17690,17881,17915,17484],0); -ELEMENTS[60381] = Fluid3D([16568,16684,16130,16766],0); -ELEMENTS[60382] = Fluid3D([2919,2833,3234,3062],0); -ELEMENTS[60383] = Fluid3D([10722,10742,11381,10349],0); -ELEMENTS[60384] = Fluid3D([11381,10722,10349,11787],0); -ELEMENTS[60385] = Fluid3D([17861,18027,17807,17605],0); -ELEMENTS[60386] = Fluid3D([15711,15895,16114,15183],0); -ELEMENTS[60387] = Fluid3D([5608,5651,6260,5671],0); -ELEMENTS[60388] = Fluid3D([14146,13638,13905,13182],0); -ELEMENTS[60389] = Fluid3D([14146,13638,13182,13890],0); -ELEMENTS[60390] = Fluid3D([13638,13905,13182,12715],0); -ELEMENTS[60391] = Fluid3D([17359,17566,17617,17215],0); -ELEMENTS[60392] = Fluid3D([8636,7823,8576,8886],0); -ELEMENTS[60393] = Fluid3D([16470,16469,16332,15851],0); -ELEMENTS[60394] = Fluid3D([18469,18340,18382,18231],0); -ELEMENTS[60395] = Fluid3D([12322,11717,12527,11901],0); -ELEMENTS[60396] = Fluid3D([12870,13537,13183,13239],0); -ELEMENTS[60397] = Fluid3D([12870,13537,13239,13018],0); -ELEMENTS[60398] = Fluid3D([13537,13239,13018,13899],0); -ELEMENTS[60399] = Fluid3D([13239,13018,13183,12433],0); -ELEMENTS[60400] = Fluid3D([13183,12870,12433,12029],0); -ELEMENTS[60401] = Fluid3D([13018,13239,13183,13899],0); -ELEMENTS[60402] = Fluid3D([13537,13239,13899,13183],0); -ELEMENTS[60403] = Fluid3D([11555,12433,11050,12072],0); -ELEMENTS[60404] = Fluid3D([12433,11430,11050,11676],0); -ELEMENTS[60405] = Fluid3D([13634,14034,13608,12870],0); -ELEMENTS[60406] = Fluid3D([13239,12870,13018,12433],0); -ELEMENTS[60407] = Fluid3D([12103,12618,12870,11833],0); -ELEMENTS[60408] = Fluid3D([12870,12618,13537,13018],0); -ELEMENTS[60409] = Fluid3D([13183,13239,12433,12870],0); -ELEMENTS[60410] = Fluid3D([18541,18439,18517,18334],0); -ELEMENTS[60411] = Fluid3D([11930,11670,10958,12069],0); -ELEMENTS[60412] = Fluid3D([14841,14794,14385,13993],0); -ELEMENTS[60413] = Fluid3D([13908,13455,13867,13112],0); -ELEMENTS[60414] = Fluid3D([2132,1969,2072,2224],0); -ELEMENTS[60415] = Fluid3D([2851,3070,2761,3038],0); -ELEMENTS[60416] = Fluid3D([2357,2611,2498,2727],0); -ELEMENTS[60417] = Fluid3D([14813,15078,15280,14304],0); -ELEMENTS[60418] = Fluid3D([16532,16878,16663,16152],0); -ELEMENTS[60419] = Fluid3D([14418,14620,14906,13780],0); -ELEMENTS[60420] = Fluid3D([17199,17212,17170,17420],0); -ELEMENTS[60421] = Fluid3D([13183,13675,13899,13877],0); -ELEMENTS[60422] = Fluid3D([13608,12870,13011,12637],0); -ELEMENTS[60423] = Fluid3D([3070,2761,3038,2985],0); -ELEMENTS[60424] = Fluid3D([13537,13899,14378,13877],0); -ELEMENTS[60425] = Fluid3D([13018,12072,12498,12433],0); -ELEMENTS[60426] = Fluid3D([17199,17212,17420,17592],0); -ELEMENTS[60427] = Fluid3D([13150,12433,13018,12498],0); -ELEMENTS[60428] = Fluid3D([12776,12364,12433,11676],0); -ELEMENTS[60429] = Fluid3D([12029,12103,12870,11833],0); -ELEMENTS[60430] = Fluid3D([12642,12776,12457,11676],0); -ELEMENTS[60431] = Fluid3D([11833,12029,12433,12870],0); -ELEMENTS[60432] = Fluid3D([13420,13150,12498,12457],0); -ELEMENTS[60433] = Fluid3D([12103,12618,11833,12072],0); -ELEMENTS[60434] = Fluid3D([2761,3038,2985,2682],0); -ELEMENTS[60435] = Fluid3D([12637,12870,13155,13634],0); -ELEMENTS[60436] = Fluid3D([13150,12776,12433,12457],0); -ELEMENTS[60437] = Fluid3D([12433,11833,12870,12618],0); -ELEMENTS[60438] = Fluid3D([11833,12433,12072,12618],0); -ELEMENTS[60439] = Fluid3D([13455,13867,13112,12568],0); -ELEMENTS[60440] = Fluid3D([13908,13455,13112,12680],0); -ELEMENTS[60441] = Fluid3D([13455,13112,12680,12568],0); -ELEMENTS[60442] = Fluid3D([13867,13908,13112,13695],0); -ELEMENTS[60443] = Fluid3D([13112,13867,13695,12895],0); -ELEMENTS[60444] = Fluid3D([13695,13112,12895,12624],0); -ELEMENTS[60445] = Fluid3D([13112,12895,12624,12568],0); -ELEMENTS[60446] = Fluid3D([13112,12895,12568,13867],0); -ELEMENTS[60447] = Fluid3D([12624,13112,12568,12680],0); -ELEMENTS[60448] = Fluid3D([12624,13112,12680,13908],0); -ELEMENTS[60449] = Fluid3D([13695,13112,12624,13908],0); -ELEMENTS[60450] = Fluid3D([8332,8951,7652,8374],0); -ELEMENTS[60451] = Fluid3D([8332,8951,8374,9020],0); -ELEMENTS[60452] = Fluid3D([1922,1862,2022,2038],0); -ELEMENTS[60453] = Fluid3D([11476,11466,10585,10797],0); -ELEMENTS[60454] = Fluid3D([3261,3123,3127,3592],0); -ELEMENTS[60455] = Fluid3D([12094,12602,12265,11294],0); -ELEMENTS[60456] = Fluid3D([17665,17436,17696,17135],0); -ELEMENTS[60457] = Fluid3D([11049,11177,11345,12380],0); -ELEMENTS[60458] = Fluid3D([16823,16990,17145,16693],0); -ELEMENTS[60459] = Fluid3D([16990,17145,16693,17299],0); -ELEMENTS[60460] = Fluid3D([16823,16990,16693,16651],0); -ELEMENTS[60461] = Fluid3D([14386,14884,14660,14020],0); -ELEMENTS[60462] = Fluid3D([4240,4461,4199,5046],0); -ELEMENTS[60463] = Fluid3D([6827,7506,6753,6671],0); -ELEMENTS[60464] = Fluid3D([7506,6753,6671,6725],0); -ELEMENTS[60465] = Fluid3D([6753,6671,6725,6042],0); -ELEMENTS[60466] = Fluid3D([6671,6725,6042,6853],0); -ELEMENTS[60467] = Fluid3D([6753,6827,6671,6136],0); -ELEMENTS[60468] = Fluid3D([6827,7506,6671,7302],0); -ELEMENTS[60469] = Fluid3D([7506,6671,7302,6725],0); -ELEMENTS[60470] = Fluid3D([18236,18367,18381,18133],0); -ELEMENTS[60471] = Fluid3D([3187,3485,3222,3560],0); -ELEMENTS[60472] = Fluid3D([2400,2565,2322,2683],0); -ELEMENTS[60473] = Fluid3D([2400,2565,2683,2664],0); -ELEMENTS[60474] = Fluid3D([2565,2683,2664,2851],0); -ELEMENTS[60475] = Fluid3D([15956,16469,16126,15676],0); -ELEMENTS[60476] = Fluid3D([5122,4885,4571,5065],0); -ELEMENTS[60477] = Fluid3D([6829,6073,6417,6608],0); -ELEMENTS[60478] = Fluid3D([6073,6417,6608,5758],0); -ELEMENTS[60479] = Fluid3D([11002,10074,10516,11363],0); -ELEMENTS[60480] = Fluid3D([17430,17536,17626,17845],0); -ELEMENTS[60481] = Fluid3D([17430,17536,17845,17750],0); -ELEMENTS[60482] = Fluid3D([17430,17536,17750,17452],0); -ELEMENTS[60483] = Fluid3D([11903,11799,10897,11851],0); -ELEMENTS[60484] = Fluid3D([11903,11799,11851,12765],0); -ELEMENTS[60485] = Fluid3D([5989,5795,5386,6007],0); -ELEMENTS[60486] = Fluid3D([5989,5795,6007,6342],0); -ELEMENTS[60487] = Fluid3D([5795,6007,6342,6321],0); -ELEMENTS[60488] = Fluid3D([6007,6342,6321,7016],0); -ELEMENTS[60489] = Fluid3D([5386,5989,6007,5594],0); -ELEMENTS[60490] = Fluid3D([5795,5386,6007,5516],0); -ELEMENTS[60491] = Fluid3D([5795,6007,6321,5516],0); -ELEMENTS[60492] = Fluid3D([6007,6321,5516,5857],0); -ELEMENTS[60493] = Fluid3D([6007,6321,5857,6449],0); -ELEMENTS[60494] = Fluid3D([5857,6007,6449,5594],0); -ELEMENTS[60495] = Fluid3D([13732,13461,13615,12712],0); -ELEMENTS[60496] = Fluid3D([18312,18266,18409,18237],0); -ELEMENTS[60497] = Fluid3D([18409,18312,18237,18448],0); -ELEMENTS[60498] = Fluid3D([18312,18237,18448,18352],0); -ELEMENTS[60499] = Fluid3D([6472,7130,7228,7233],0); -ELEMENTS[60500] = Fluid3D([6853,6109,6281,6042],0); -ELEMENTS[60501] = Fluid3D([18227,18071,18245,17959],0); -ELEMENTS[60502] = Fluid3D([15151,14852,14378,14874],0); -ELEMENTS[60503] = Fluid3D([18138,18283,18298,18177],0); -ELEMENTS[60504] = Fluid3D([5984,5426,6133,5812],0); -ELEMENTS[60505] = Fluid3D([15995,16220,16376,15798],0); -ELEMENTS[60506] = Fluid3D([7561,6769,6961,6304],0); -ELEMENTS[60507] = Fluid3D([16995,17295,17081,16799],0); -ELEMENTS[60508] = Fluid3D([17081,16995,16799,16762],0); -ELEMENTS[60509] = Fluid3D([5527,5079,4980,5335],0); -ELEMENTS[60510] = Fluid3D([16721,16169,16406,16308],0); -ELEMENTS[60511] = Fluid3D([6721,6285,7082,6566],0); -ELEMENTS[60512] = Fluid3D([2644,2334,2563,2537],0); -ELEMENTS[60513] = Fluid3D([17498,17661,17382,17375],0); -ELEMENTS[60514] = Fluid3D([17498,17661,17375,17763],0); -ELEMENTS[60515] = Fluid3D([17375,17498,17763,17554],0); -ELEMENTS[60516] = Fluid3D([12072,11078,11531,11074],0); -ELEMENTS[60517] = Fluid3D([11078,11531,11074,10519],0); -ELEMENTS[60518] = Fluid3D([11531,11074,10519,10980],0); -ELEMENTS[60519] = Fluid3D([11531,12072,11074,12498],0); -ELEMENTS[60520] = Fluid3D([2504,2586,2344,2609],0); -ELEMENTS[60521] = Fluid3D([2586,2344,2609,2423],0); -ELEMENTS[60522] = Fluid3D([13980,14064,14450,13055],0); -ELEMENTS[60523] = Fluid3D([16665,16420,16321,16033],0); -ELEMENTS[60524] = Fluid3D([16420,16321,16033,16048],0); -ELEMENTS[60525] = Fluid3D([16665,16420,16033,16762],0); -ELEMENTS[60526] = Fluid3D([12363,11670,12599,12368],0); -ELEMENTS[60527] = Fluid3D([7314,7616,6804,7167],0); -ELEMENTS[60528] = Fluid3D([18523,18408,18483,18393],0); -ELEMENTS[60529] = Fluid3D([13979,13601,13524,12963],0); -ELEMENTS[60530] = Fluid3D([18453,18401,18260,18210],0); -ELEMENTS[60531] = Fluid3D([18033,18167,17976,17825],0); -ELEMENTS[60532] = Fluid3D([3094,3468,3312,3776],0); -ELEMENTS[60533] = Fluid3D([17488,17356,17571,17871],0); -ELEMENTS[60534] = Fluid3D([16703,16953,17233,16738],0); -ELEMENTS[60535] = Fluid3D([16170,16384,15778,16434],0); -ELEMENTS[60536] = Fluid3D([16540,16577,16249,15888],0); -ELEMENTS[60537] = Fluid3D([17276,16829,17010,16593],0); -ELEMENTS[60538] = Fluid3D([3778,3326,3737,3562],0); -ELEMENTS[60539] = Fluid3D([13327,12857,13217,13836],0); -ELEMENTS[60540] = Fluid3D([15451,14977,15660,15303],0); -ELEMENTS[60541] = Fluid3D([7309,6489,6825,6966],0); -ELEMENTS[60542] = Fluid3D([6489,6825,6966,6075],0); -ELEMENTS[60543] = Fluid3D([1849,1964,1995,2109],0); -ELEMENTS[60544] = Fluid3D([16028,15912,15623,15376],0); -ELEMENTS[60545] = Fluid3D([14449,14833,14913,14021],0); -ELEMENTS[60546] = Fluid3D([6205,5620,5705,5593],0); -ELEMENTS[60547] = Fluid3D([6205,5620,5593,6136],0); -ELEMENTS[60548] = Fluid3D([5620,5705,5593,5379],0); -ELEMENTS[60549] = Fluid3D([5620,5593,6136,5707],0); -ELEMENTS[60550] = Fluid3D([5620,5593,5707,5114],0); -ELEMENTS[60551] = Fluid3D([5593,5707,5114,5827],0); -ELEMENTS[60552] = Fluid3D([5593,5707,5827,6403],0); -ELEMENTS[60553] = Fluid3D([5707,5114,5827,5363],0); -ELEMENTS[60554] = Fluid3D([5827,5707,5363,6042],0); -ELEMENTS[60555] = Fluid3D([5593,6136,5707,6205],0); -ELEMENTS[60556] = Fluid3D([5705,6205,5593,6065],0); -ELEMENTS[60557] = Fluid3D([18278,18415,18437,18247],0); -ELEMENTS[60558] = Fluid3D([18278,18415,18247,18186],0); -ELEMENTS[60559] = Fluid3D([18437,18278,18247,18302],0); -ELEMENTS[60560] = Fluid3D([6078,5467,5918,6102],0); -ELEMENTS[60561] = Fluid3D([12304,11864,12676,12759],0); -ELEMENTS[60562] = Fluid3D([18577,18533,18609,18473],0); -ELEMENTS[60563] = Fluid3D([18577,18533,18473,18492],0); -ELEMENTS[60564] = Fluid3D([18533,18473,18492,18417],0); -ELEMENTS[60565] = Fluid3D([18533,18473,18417,18524],0); -ELEMENTS[60566] = Fluid3D([18473,18577,18492,18436],0); -ELEMENTS[60567] = Fluid3D([14228,13360,13692,13750],0); -ELEMENTS[60568] = Fluid3D([13692,14228,13750,14524],0); -ELEMENTS[60569] = Fluid3D([16710,16981,17209,17034],0); -ELEMENTS[60570] = Fluid3D([16981,17209,17034,17357],0); -ELEMENTS[60571] = Fluid3D([17034,16981,17357,17200],0); -ELEMENTS[60572] = Fluid3D([16981,17209,17357,17508],0); -ELEMENTS[60573] = Fluid3D([8805,8749,7890,8473],0); -ELEMENTS[60574] = Fluid3D([8805,8749,8473,9693],0); -ELEMENTS[60575] = Fluid3D([7890,8805,8473,7983],0); -ELEMENTS[60576] = Fluid3D([8749,7890,8473,7841],0); -ELEMENTS[60577] = Fluid3D([7890,8473,7841,7602],0); -ELEMENTS[60578] = Fluid3D([8473,7841,7602,8575],0); -ELEMENTS[60579] = Fluid3D([7890,8473,7602,7983],0); -ELEMENTS[60580] = Fluid3D([8473,7602,7983,8575],0); -ELEMENTS[60581] = Fluid3D([7602,7890,7983,7958],0); -ELEMENTS[60582] = Fluid3D([7983,7602,7958,7086],0); -ELEMENTS[60583] = Fluid3D([7983,7602,7086,7539],0); -ELEMENTS[60584] = Fluid3D([7602,7086,7539,6909],0); -ELEMENTS[60585] = Fluid3D([7983,7602,7539,8575],0); -ELEMENTS[60586] = Fluid3D([12082,11580,12252,12503],0); -ELEMENTS[60587] = Fluid3D([6500,7165,6444,7477],0); -ELEMENTS[60588] = Fluid3D([12146,11853,11028,11759],0); -ELEMENTS[60589] = Fluid3D([12146,11853,11759,12241],0); -ELEMENTS[60590] = Fluid3D([11853,11759,12241,11445],0); -ELEMENTS[60591] = Fluid3D([11853,11759,11445,11028],0); -ELEMENTS[60592] = Fluid3D([11445,11853,11028,11042],0); -ELEMENTS[60593] = Fluid3D([11759,12146,12241,12223],0); -ELEMENTS[60594] = Fluid3D([12241,11759,12223,11686],0); -ELEMENTS[60595] = Fluid3D([11759,12146,12223,11462],0); -ELEMENTS[60596] = Fluid3D([12146,12223,11462,11058],0); -ELEMENTS[60597] = Fluid3D([11462,12146,11058,11028],0); -ELEMENTS[60598] = Fluid3D([11058,11462,11028,10912],0); -ELEMENTS[60599] = Fluid3D([11058,11462,10912,12223],0); -ELEMENTS[60600] = Fluid3D([11462,11028,10912,11759],0); -ELEMENTS[60601] = Fluid3D([10912,11462,11759,12223],0); -ELEMENTS[60602] = Fluid3D([11759,12146,11462,11028],0); -ELEMENTS[60603] = Fluid3D([11028,10912,11759,11168],0); -ELEMENTS[60604] = Fluid3D([10912,11759,11168,11686],0); -ELEMENTS[60605] = Fluid3D([11759,12241,11445,11168],0); -ELEMENTS[60606] = Fluid3D([11759,12241,11168,11686],0); -ELEMENTS[60607] = Fluid3D([16824,16737,17055,16257],0); -ELEMENTS[60608] = Fluid3D([10853,10907,10097,10424],0); -ELEMENTS[60609] = Fluid3D([17968,17886,17723,17610],0); -ELEMENTS[60610] = Fluid3D([7728,7872,8116,6923],0); -ELEMENTS[60611] = Fluid3D([12838,11883,12243,12747],0); -ELEMENTS[60612] = Fluid3D([11375,11746,10756,11675],0); -ELEMENTS[60613] = Fluid3D([10756,11375,11675,10371],0); -ELEMENTS[60614] = Fluid3D([11375,11746,11675,12343],0); -ELEMENTS[60615] = Fluid3D([11746,10756,11675,11161],0); -ELEMENTS[60616] = Fluid3D([16172,16350,16564,16164],0); -ELEMENTS[60617] = Fluid3D([14284,13923,14410,13334],0); -ELEMENTS[60618] = Fluid3D([15743,15342,15663,14883],0); -ELEMENTS[60619] = Fluid3D([6979,6533,7185,6178],0); -ELEMENTS[60620] = Fluid3D([14637,13763,13972,13957],0); -ELEMENTS[60621] = Fluid3D([17914,18184,18125,18094],0); -ELEMENTS[60622] = Fluid3D([17914,18184,18094,18000],0); -ELEMENTS[60623] = Fluid3D([18184,18094,18000,18260],0); -ELEMENTS[60624] = Fluid3D([18184,18094,18260,18401],0); -ELEMENTS[60625] = Fluid3D([18184,18094,18401,18212],0); -ELEMENTS[60626] = Fluid3D([18184,18094,18212,18125],0); -ELEMENTS[60627] = Fluid3D([4155,3884,4355,4477],0); -ELEMENTS[60628] = Fluid3D([3884,4355,4477,4060],0); -ELEMENTS[60629] = Fluid3D([4355,4155,4477,4657],0); -ELEMENTS[60630] = Fluid3D([4355,4477,4060,4571],0); -ELEMENTS[60631] = Fluid3D([4477,4355,4657,5065],0); -ELEMENTS[60632] = Fluid3D([4477,4355,5065,4571],0); -ELEMENTS[60633] = Fluid3D([18621,18558,18576,18486],0); -ELEMENTS[60634] = Fluid3D([15972,15764,16153,15423],0); -ELEMENTS[60635] = Fluid3D([8428,9213,8305,8678],0); -ELEMENTS[60636] = Fluid3D([8428,9213,8678,8547],0); -ELEMENTS[60637] = Fluid3D([4573,4681,4851,5123],0); -ELEMENTS[60638] = Fluid3D([4573,4681,5123,4935],0); -ELEMENTS[60639] = Fluid3D([4681,5123,4935,4979],0); -ELEMENTS[60640] = Fluid3D([4681,5123,4979,4875],0); -ELEMENTS[60641] = Fluid3D([5123,4935,4979,5384],0); -ELEMENTS[60642] = Fluid3D([17427,17395,17655,17176],0); -ELEMENTS[60643] = Fluid3D([17427,17395,17176,17152],0); -ELEMENTS[60644] = Fluid3D([17176,17427,17152,17190],0); -ELEMENTS[60645] = Fluid3D([14437,15306,15360,15019],0); -ELEMENTS[60646] = Fluid3D([15306,15360,15019,15413],0); -ELEMENTS[60647] = Fluid3D([15360,15019,15413,14572],0); -ELEMENTS[60648] = Fluid3D([15019,15413,14572,15091],0); -ELEMENTS[60649] = Fluid3D([15019,15413,15091,15617],0); -ELEMENTS[60650] = Fluid3D([14572,15019,15091,14561],0); -ELEMENTS[60651] = Fluid3D([14572,15019,14561,14437],0); -ELEMENTS[60652] = Fluid3D([15019,15091,14561,15617],0); -ELEMENTS[60653] = Fluid3D([15019,15413,15617,15306],0); -ELEMENTS[60654] = Fluid3D([15091,14572,14561,14182],0); -ELEMENTS[60655] = Fluid3D([15413,15091,15617,15230],0); -ELEMENTS[60656] = Fluid3D([15413,15091,15230,14572],0); -ELEMENTS[60657] = Fluid3D([15091,15230,14572,14182],0); -ELEMENTS[60658] = Fluid3D([15091,15617,15230,15378],0); -ELEMENTS[60659] = Fluid3D([15230,15091,15378,14891],0); -ELEMENTS[60660] = Fluid3D([15230,15413,14572,15209],0); -ELEMENTS[60661] = Fluid3D([15230,15413,15209,15931],0); -ELEMENTS[60662] = Fluid3D([15230,15413,15931,15617],0); -ELEMENTS[60663] = Fluid3D([15413,15931,15617,15306],0); -ELEMENTS[60664] = Fluid3D([14572,15019,14437,15360],0); -ELEMENTS[60665] = Fluid3D([14437,15306,15019,15015],0); -ELEMENTS[60666] = Fluid3D([2314,2449,2212,2403],0); -ELEMENTS[60667] = Fluid3D([2449,2212,2403,2349],0); -ELEMENTS[60668] = Fluid3D([8139,8642,9050,9141],0); -ELEMENTS[60669] = Fluid3D([12151,11685,11736,10973],0); -ELEMENTS[60670] = Fluid3D([11685,11736,10973,10354],0); -ELEMENTS[60671] = Fluid3D([12151,11685,10973,11455],0); -ELEMENTS[60672] = Fluid3D([2509,2469,2729,2649],0); -ELEMENTS[60673] = Fluid3D([17551,17096,17246,17234],0); -ELEMENTS[60674] = Fluid3D([6369,5891,6534,6650],0); -ELEMENTS[60675] = Fluid3D([5053,5715,5231,5572],0); -ELEMENTS[60676] = Fluid3D([7939,7082,7514,7750],0); -ELEMENTS[60677] = Fluid3D([18690,18672,18680,18650],0); -ELEMENTS[60678] = Fluid3D([18672,18680,18650,18645],0); -ELEMENTS[60679] = Fluid3D([18680,18650,18645,18625],0); -ELEMENTS[60680] = Fluid3D([18650,18672,18645,18588],0); -ELEMENTS[60681] = Fluid3D([18490,18569,18563,18488],0); -ELEMENTS[60682] = Fluid3D([18490,18569,18488,18500],0); -ELEMENTS[60683] = Fluid3D([18563,18490,18488,18476],0); -ELEMENTS[60684] = Fluid3D([18488,18563,18476,18569],0); -ELEMENTS[60685] = Fluid3D([18490,18488,18476,18309],0); -ELEMENTS[60686] = Fluid3D([18476,18488,18569,18499],0); -ELEMENTS[60687] = Fluid3D([18488,18569,18499,18500],0); -ELEMENTS[60688] = Fluid3D([9927,11067,10526,11076],0); -ELEMENTS[60689] = Fluid3D([16326,16461,16837,16528],0); -ELEMENTS[60690] = Fluid3D([8093,7387,8340,7978],0); -ELEMENTS[60691] = Fluid3D([14054,14303,13802,13438],0); -ELEMENTS[60692] = Fluid3D([11709,11998,12174,11016],0); -ELEMENTS[60693] = Fluid3D([5760,6209,5598,5670],0); -ELEMENTS[60694] = Fluid3D([4173,4651,4276,4661],0); -ELEMENTS[60695] = Fluid3D([4651,4276,4661,4763],0); -ELEMENTS[60696] = Fluid3D([16520,17066,16880,17019],0); -ELEMENTS[60697] = Fluid3D([3712,3880,4259,4231],0); -ELEMENTS[60698] = Fluid3D([3880,4259,4231,4384],0); -ELEMENTS[60699] = Fluid3D([3880,4259,4384,4171],0); -ELEMENTS[60700] = Fluid3D([16039,15406,15723,15225],0); -ELEMENTS[60701] = Fluid3D([12451,11940,12139,11190],0); -ELEMENTS[60702] = Fluid3D([14823,14620,14323,13715],0); -ELEMENTS[60703] = Fluid3D([9764,8876,9851,9892],0); -ELEMENTS[60704] = Fluid3D([9851,9764,9892,10779],0); -ELEMENTS[60705] = Fluid3D([17644,17234,17551,17630],0); -ELEMENTS[60706] = Fluid3D([14893,14308,15065,14608],0); -ELEMENTS[60707] = Fluid3D([14308,15065,14608,14519],0); -ELEMENTS[60708] = Fluid3D([15065,14608,14519,14580],0); -ELEMENTS[60709] = Fluid3D([6592,6928,6162,6942],0); -ELEMENTS[60710] = Fluid3D([8447,9427,9244,8735],0); -ELEMENTS[60711] = Fluid3D([17374,17389,17006,16745],0); -ELEMENTS[60712] = Fluid3D([7297,7094,6809,7820],0); -ELEMENTS[60713] = Fluid3D([12026,11033,12464,12087],0); -ELEMENTS[60714] = Fluid3D([12464,12026,12087,12751],0); -ELEMENTS[60715] = Fluid3D([12026,12087,12751,12002],0); -ELEMENTS[60716] = Fluid3D([12087,12751,12002,11272],0); -ELEMENTS[60717] = Fluid3D([12026,12087,12002,11033],0); -ELEMENTS[60718] = Fluid3D([14838,14995,15288,14267],0); -ELEMENTS[60719] = Fluid3D([13831,14317,14054,13386],0); -ELEMENTS[60720] = Fluid3D([16548,16025,16287,16317],0); -ELEMENTS[60721] = Fluid3D([16548,16025,16317,16131],0); -ELEMENTS[60722] = Fluid3D([16025,16287,16317,15596],0); -ELEMENTS[60723] = Fluid3D([16025,16287,15596,15638],0); -ELEMENTS[60724] = Fluid3D([15596,16025,15638,14997],0); -ELEMENTS[60725] = Fluid3D([16025,16287,15638,16377],0); -ELEMENTS[60726] = Fluid3D([16025,16287,16377,16597],0); -ELEMENTS[60727] = Fluid3D([18168,18070,18259,18096],0); -ELEMENTS[60728] = Fluid3D([16239,16775,16495,16411],0); -ELEMENTS[60729] = Fluid3D([3310,3714,3557,3881],0); -ELEMENTS[60730] = Fluid3D([14346,14838,14683,13962],0); -ELEMENTS[60731] = Fluid3D([3210,3563,3226,3160],0); -ELEMENTS[60732] = Fluid3D([3563,3226,3160,3557],0); -ELEMENTS[60733] = Fluid3D([3160,3563,3557,3470],0); -ELEMENTS[60734] = Fluid3D([9433,9338,9664,8917],0); -ELEMENTS[60735] = Fluid3D([17390,16962,17112,16885],0); -ELEMENTS[60736] = Fluid3D([16370,15729,15962,16045],0); -ELEMENTS[60737] = Fluid3D([15962,16370,16045,16568],0); -ELEMENTS[60738] = Fluid3D([16370,15729,16045,16404],0); -ELEMENTS[60739] = Fluid3D([15231,15258,14515,14575],0); -ELEMENTS[60740] = Fluid3D([15258,14515,14575,14946],0); -ELEMENTS[60741] = Fluid3D([11667,11265,11194,10299],0); -ELEMENTS[60742] = Fluid3D([14878,15267,15572,15432],0); -ELEMENTS[60743] = Fluid3D([5445,6054,5920,5856],0); -ELEMENTS[60744] = Fluid3D([4919,4763,5324,5332],0); -ELEMENTS[60745] = Fluid3D([18512,18468,18390,18392],0); -ELEMENTS[60746] = Fluid3D([18512,18468,18392,18564],0); -ELEMENTS[60747] = Fluid3D([18390,18512,18392,18443],0); -ELEMENTS[60748] = Fluid3D([16448,16343,15896,16259],0); -ELEMENTS[60749] = Fluid3D([14378,13899,14736,13877],0); -ELEMENTS[60750] = Fluid3D([2781,2558,2509,2825],0); -ELEMENTS[60751] = Fluid3D([7241,8044,8502,7749],0); -ELEMENTS[60752] = Fluid3D([15032,14823,14558,14027],0); -ELEMENTS[60753] = Fluid3D([6967,6823,6232,7594],0); -ELEMENTS[60754] = Fluid3D([3234,3139,3595,3339],0); -ELEMENTS[60755] = Fluid3D([5062,4510,4762,4973],0); -ELEMENTS[60756] = Fluid3D([5062,4510,4973,4796],0); -ELEMENTS[60757] = Fluid3D([9441,9065,8514,9668],0); -ELEMENTS[60758] = Fluid3D([9441,9065,9668,10021],0); -ELEMENTS[60759] = Fluid3D([9668,9441,10021,10688],0); -ELEMENTS[60760] = Fluid3D([3675,4101,3647,3437],0); -ELEMENTS[60761] = Fluid3D([13191,12710,12810,11812],0); -ELEMENTS[60762] = Fluid3D([4203,4052,3810,4327],0); -ELEMENTS[60763] = Fluid3D([4203,4052,4327,4756],0); -ELEMENTS[60764] = Fluid3D([4052,3810,4327,4044],0); -ELEMENTS[60765] = Fluid3D([13106,12602,12964,11976],0); -ELEMENTS[60766] = Fluid3D([17907,18040,17819,17754],0); -ELEMENTS[60767] = Fluid3D([12579,12790,13555,12476],0); -ELEMENTS[60768] = Fluid3D([9516,10628,10145,10079],0); -ELEMENTS[60769] = Fluid3D([7523,8288,7371,8043],0); -ELEMENTS[60770] = Fluid3D([16663,16310,16532,16152],0); -ELEMENTS[60771] = Fluid3D([8285,8186,7506,7302],0); -ELEMENTS[60772] = Fluid3D([2296,2391,2548,2710],0); -ELEMENTS[60773] = Fluid3D([15934,16302,15698,15654],0); -ELEMENTS[60774] = Fluid3D([16137,16501,16387,16060],0); -ELEMENTS[60775] = Fluid3D([16501,16387,16060,16736],0); -ELEMENTS[60776] = Fluid3D([16137,16501,16060,16269],0); -ELEMENTS[60777] = Fluid3D([16387,16137,16060,15913],0); -ELEMENTS[60778] = Fluid3D([16060,16387,15913,16736],0); -ELEMENTS[60779] = Fluid3D([16060,16501,16736,15927],0); -ELEMENTS[60780] = Fluid3D([16501,16060,16269,15716],0); -ELEMENTS[60781] = Fluid3D([16060,16501,15927,16201],0); -ELEMENTS[60782] = Fluid3D([16060,16501,16201,15716],0); -ELEMENTS[60783] = Fluid3D([2212,2349,2130,2403],0); -ELEMENTS[60784] = Fluid3D([5890,5255,5869,6165],0); -ELEMENTS[60785] = Fluid3D([12117,12743,11803,11133],0); -ELEMENTS[60786] = Fluid3D([1639,1575,1563,1641],0); -ELEMENTS[60787] = Fluid3D([16334,16163,15941,15705],0); -ELEMENTS[60788] = Fluid3D([12663,12452,12968,11495],0); -ELEMENTS[60789] = Fluid3D([10295,10696,9567,10550],0); -ELEMENTS[60790] = Fluid3D([6437,6992,6226,7285],0); -ELEMENTS[60791] = Fluid3D([6992,6226,7285,6765],0); -ELEMENTS[60792] = Fluid3D([7285,6992,6765,7569],0); -ELEMENTS[60793] = Fluid3D([10739,11526,10420,10970],0); -ELEMENTS[60794] = Fluid3D([18672,18626,18645,18588],0); -ELEMENTS[60795] = Fluid3D([2763,2590,2490,2710],0); -ELEMENTS[60796] = Fluid3D([2490,2763,2710,2650],0); -ELEMENTS[60797] = Fluid3D([2710,2490,2650,2296],0); -ELEMENTS[60798] = Fluid3D([2590,2490,2710,2507],0); -ELEMENTS[60799] = Fluid3D([2490,2710,2507,2391],0); -ELEMENTS[60800] = Fluid3D([17871,17888,18071,17770],0); -ELEMENTS[60801] = Fluid3D([2511,2476,2280,2542],0); -ELEMENTS[60802] = Fluid3D([15820,15409,15659,14865],0); -ELEMENTS[60803] = Fluid3D([1821,1973,1885,2079],0); -ELEMENTS[60804] = Fluid3D([9936,10056,10850,11277],0); -ELEMENTS[60805] = Fluid3D([17433,17904,17671,17909],0); -ELEMENTS[60806] = Fluid3D([17904,17671,17909,18130],0); -ELEMENTS[60807] = Fluid3D([17909,17904,18130,18264],0); -ELEMENTS[60808] = Fluid3D([5079,4562,4980,5335],0); -ELEMENTS[60809] = Fluid3D([12785,12585,13320,12239],0); -ELEMENTS[60810] = Fluid3D([14047,13253,13812,14009],0); -ELEMENTS[60811] = Fluid3D([13856,12970,13330,14045],0); -ELEMENTS[60812] = Fluid3D([3104,3219,2878,3205],0); -ELEMENTS[60813] = Fluid3D([2878,3104,3205,2789],0); -ELEMENTS[60814] = Fluid3D([7262,8046,7149,7425],0); -ELEMENTS[60815] = Fluid3D([16168,16048,16420,15763],0); -ELEMENTS[60816] = Fluid3D([4751,4891,5294,5144],0); -ELEMENTS[60817] = Fluid3D([10618,10969,11680,10814],0); -ELEMENTS[60818] = Fluid3D([11191,11939,12138,12452],0); -ELEMENTS[60819] = Fluid3D([14088,14256,14923,14488],0); -ELEMENTS[60820] = Fluid3D([18300,18167,18340,18226],0); -ELEMENTS[60821] = Fluid3D([18340,18300,18226,18435],0); -ELEMENTS[60822] = Fluid3D([18226,18340,18435,18292],0); -ELEMENTS[60823] = Fluid3D([18435,18226,18292,18300],0); -ELEMENTS[60824] = Fluid3D([18226,18340,18292,18160],0); -ELEMENTS[60825] = Fluid3D([18292,18226,18160,18039],0); -ELEMENTS[60826] = Fluid3D([18292,18226,18039,18300],0); -ELEMENTS[60827] = Fluid3D([8458,7817,8552,7706],0); -ELEMENTS[60828] = Fluid3D([15005,15179,14719,14387],0); -ELEMENTS[60829] = Fluid3D([5781,6161,6333,6297],0); -ELEMENTS[60830] = Fluid3D([6467,6207,6715,5770],0); -ELEMENTS[60831] = Fluid3D([6715,6467,5770,6043],0); -ELEMENTS[60832] = Fluid3D([6715,6467,6043,6348],0); -ELEMENTS[60833] = Fluid3D([16292,16577,16628,15963],0); -ELEMENTS[60834] = Fluid3D([17568,17257,17381,17753],0); -ELEMENTS[60835] = Fluid3D([17400,17326,17776,17675],0); -ELEMENTS[60836] = Fluid3D([5694,5978,5719,6689],0); -ELEMENTS[60837] = Fluid3D([5905,6162,5538,5886],0); -ELEMENTS[60838] = Fluid3D([13979,14449,14074,13352],0); -ELEMENTS[60839] = Fluid3D([15411,14637,14844,15515],0); -ELEMENTS[60840] = Fluid3D([4418,4850,4890,4595],0); -ELEMENTS[60841] = Fluid3D([13548,14069,14528,14194],0); -ELEMENTS[60842] = Fluid3D([6503,5840,6266,6639],0); -ELEMENTS[60843] = Fluid3D([18121,18190,18306,17925],0); -ELEMENTS[60844] = Fluid3D([3877,4054,3630,3970],0); -ELEMENTS[60845] = Fluid3D([14331,14732,15195,15142],0); -ELEMENTS[60846] = Fluid3D([18115,17954,18147,17935],0); -ELEMENTS[60847] = Fluid3D([12456,13056,12117,12435],0); -ELEMENTS[60848] = Fluid3D([11890,11051,12074,12165],0); -ELEMENTS[60849] = Fluid3D([6205,6827,6136,5707],0); -ELEMENTS[60850] = Fluid3D([6584,7346,7257,7123],0); -ELEMENTS[60851] = Fluid3D([17190,17233,16953,16738],0); -ELEMENTS[60852] = Fluid3D([5356,4903,4835,5293],0); -ELEMENTS[60853] = Fluid3D([4835,5356,5293,5605],0); -ELEMENTS[60854] = Fluid3D([5293,4835,5605,4849],0); -ELEMENTS[60855] = Fluid3D([4903,4835,5293,4849],0); -ELEMENTS[60856] = Fluid3D([5293,4903,4849,5459],0); -ELEMENTS[60857] = Fluid3D([4849,5293,5459,5605],0); -ELEMENTS[60858] = Fluid3D([5293,5459,5605,5775],0); -ELEMENTS[60859] = Fluid3D([5293,5459,5775,4903],0); -ELEMENTS[60860] = Fluid3D([5356,4903,5293,5775],0); -ELEMENTS[60861] = Fluid3D([5356,5293,5605,5775],0); -ELEMENTS[60862] = Fluid3D([13022,13902,13470,13532],0); -ELEMENTS[60863] = Fluid3D([17988,17923,17668,17727],0); -ELEMENTS[60864] = Fluid3D([2173,2445,2213,2270],0); -ELEMENTS[60865] = Fluid3D([11746,12148,11161,12044],0); -ELEMENTS[60866] = Fluid3D([13277,13179,12871,12527],0); -ELEMENTS[60867] = Fluid3D([13277,13179,12527,12298],0); -ELEMENTS[60868] = Fluid3D([12871,13277,12527,13023],0); -ELEMENTS[60869] = Fluid3D([13179,12871,12527,12478],0); -ELEMENTS[60870] = Fluid3D([13277,13179,12298,13433],0); -ELEMENTS[60871] = Fluid3D([12527,12871,13023,11901],0); -ELEMENTS[60872] = Fluid3D([12527,13277,12298,12611],0); -ELEMENTS[60873] = Fluid3D([13923,13580,14076,12950],0); -ELEMENTS[60874] = Fluid3D([2806,2529,2692,2863],0); -ELEMENTS[60875] = Fluid3D([16522,16944,16390,16506],0); -ELEMENTS[60876] = Fluid3D([5807,5854,5512,5894],0); -ELEMENTS[60877] = Fluid3D([16799,16189,16226,16071],0); -ELEMENTS[60878] = Fluid3D([16189,16226,16071,15577],0); -ELEMENTS[60879] = Fluid3D([16226,16071,15577,15892],0); -ELEMENTS[60880] = Fluid3D([16226,16799,16071,16160],0); -ELEMENTS[60881] = Fluid3D([16071,16226,16160,15892],0); -ELEMENTS[60882] = Fluid3D([16226,16160,15892,16364],0); -ELEMENTS[60883] = Fluid3D([17847,17937,17698,17658],0); -ELEMENTS[60884] = Fluid3D([17847,17937,17658,18066],0); -ELEMENTS[60885] = Fluid3D([17698,17847,17658,17277],0); -ELEMENTS[60886] = Fluid3D([6472,6560,5930,6780],0); -ELEMENTS[60887] = Fluid3D([6560,5930,6780,6015],0); -ELEMENTS[60888] = Fluid3D([6472,6560,6780,7233],0); -ELEMENTS[60889] = Fluid3D([6560,6780,7233,7330],0); -ELEMENTS[60890] = Fluid3D([6780,6560,6015,6680],0); -ELEMENTS[60891] = Fluid3D([6780,6560,6680,7330],0); -ELEMENTS[60892] = Fluid3D([12964,13466,13106,12038],0); -ELEMENTS[60893] = Fluid3D([13335,13555,14256,13689],0); -ELEMENTS[60894] = Fluid3D([14256,13335,13689,14488],0); -ELEMENTS[60895] = Fluid3D([13335,13555,13689,12899],0); -ELEMENTS[60896] = Fluid3D([13689,13335,12899,13743],0); -ELEMENTS[60897] = Fluid3D([12899,13689,13743,13609],0); -ELEMENTS[60898] = Fluid3D([13689,13743,13609,14602],0); -ELEMENTS[60899] = Fluid3D([13609,13689,14602,13555],0); -ELEMENTS[60900] = Fluid3D([13609,13689,13555,13050],0); -ELEMENTS[60901] = Fluid3D([13609,13689,13050,12899],0); -ELEMENTS[60902] = Fluid3D([13689,13050,12899,13555],0); -ELEMENTS[60903] = Fluid3D([13555,13609,13050,12476],0); -ELEMENTS[60904] = Fluid3D([13609,13050,12476,12955],0); -ELEMENTS[60905] = Fluid3D([13689,13743,14602,14488],0); -ELEMENTS[60906] = Fluid3D([13689,13743,14488,13335],0); -ELEMENTS[60907] = Fluid3D([13050,13609,12899,12955],0); -ELEMENTS[60908] = Fluid3D([13555,14256,13689,14602],0); -ELEMENTS[60909] = Fluid3D([14256,13689,14602,14488],0); -ELEMENTS[60910] = Fluid3D([12899,13050,12955,12476],0); -ELEMENTS[60911] = Fluid3D([1677,1644,1739,1740],0); -ELEMENTS[60912] = Fluid3D([15170,14763,14794,14479],0); -ELEMENTS[60913] = Fluid3D([15170,14763,14479,15142],0); -ELEMENTS[60914] = Fluid3D([14794,15170,14479,14589],0); -ELEMENTS[60915] = Fluid3D([14763,14794,14479,13961],0); -ELEMENTS[60916] = Fluid3D([14794,14479,13961,13993],0); -ELEMENTS[60917] = Fluid3D([14479,14763,13961,13756],0); -ELEMENTS[60918] = Fluid3D([13961,14479,13756,13858],0); -ELEMENTS[60919] = Fluid3D([2630,2816,2941,3191],0); -ELEMENTS[60920] = Fluid3D([3847,3572,3993,4120],0); -ELEMENTS[60921] = Fluid3D([8048,8460,9067,8282],0); -ELEMENTS[60922] = Fluid3D([8048,8460,8282,7489],0); -ELEMENTS[60923] = Fluid3D([8460,8282,7489,7904],0); -ELEMENTS[60924] = Fluid3D([8460,9067,8282,9516],0); -ELEMENTS[60925] = Fluid3D([10947,10139,11092,10675],0); -ELEMENTS[60926] = Fluid3D([10139,11092,10675,9883],0); -ELEMENTS[60927] = Fluid3D([11092,10947,10675,11867],0); -ELEMENTS[60928] = Fluid3D([11092,10675,9883,10297],0); -ELEMENTS[60929] = Fluid3D([10823,10030,10987,11158],0); -ELEMENTS[60930] = Fluid3D([10987,10823,11158,11754],0); -ELEMENTS[60931] = Fluid3D([10030,10987,11158,10605],0); -ELEMENTS[60932] = Fluid3D([3962,3623,3579,3861],0); -ELEMENTS[60933] = Fluid3D([8891,9690,9293,9064],0); -ELEMENTS[60934] = Fluid3D([13444,12840,13959,12928],0); -ELEMENTS[60935] = Fluid3D([2245,2469,2276,2481],0); -ELEMENTS[60936] = Fluid3D([15190,15460,15028,14427],0); -ELEMENTS[60937] = Fluid3D([8835,9720,8982,9554],0); -ELEMENTS[60938] = Fluid3D([9720,8982,9554,9703],0); -ELEMENTS[60939] = Fluid3D([8982,8835,9554,8728],0); -ELEMENTS[60940] = Fluid3D([9554,8982,8728,9703],0); -ELEMENTS[60941] = Fluid3D([8835,9720,9554,9836],0); -ELEMENTS[60942] = Fluid3D([9554,8835,9836,9299],0); -ELEMENTS[60943] = Fluid3D([9720,9554,9836,10408],0); -ELEMENTS[60944] = Fluid3D([9554,9836,10408,9299],0); -ELEMENTS[60945] = Fluid3D([10408,9554,9299,10289],0); -ELEMENTS[60946] = Fluid3D([10408,9554,10289,10795],0); -ELEMENTS[60947] = Fluid3D([18136,18312,18180,18056],0); -ELEMENTS[60948] = Fluid3D([6361,6721,7155,6835],0); -ELEMENTS[60949] = Fluid3D([6361,6721,6835,5981],0); -ELEMENTS[60950] = Fluid3D([6721,6835,5981,6566],0); -ELEMENTS[60951] = Fluid3D([6835,6361,5981,6115],0); -ELEMENTS[60952] = Fluid3D([6835,6361,6115,6796],0); -ELEMENTS[60953] = Fluid3D([6361,6115,6796,5712],0); -ELEMENTS[60954] = Fluid3D([6835,6361,6796,7155],0); -ELEMENTS[60955] = Fluid3D([6361,6115,5712,5981],0); -ELEMENTS[60956] = Fluid3D([6115,5712,5981,6190],0); -ELEMENTS[60957] = Fluid3D([6115,5712,6190,5811],0); -ELEMENTS[60958] = Fluid3D([6190,6115,5811,6300],0); -ELEMENTS[60959] = Fluid3D([6115,5811,6300,5712],0); -ELEMENTS[60960] = Fluid3D([6115,6835,6796,6190],0); -ELEMENTS[60961] = Fluid3D([6115,6835,6190,5981],0); -ELEMENTS[60962] = Fluid3D([6796,6115,6190,6300],0); -ELEMENTS[60963] = Fluid3D([6796,6115,6300,6075],0); -ELEMENTS[60964] = Fluid3D([6300,6115,5712,6075],0); -ELEMENTS[60965] = Fluid3D([6115,5712,6075,6796],0); -ELEMENTS[60966] = Fluid3D([15278,14729,15493,14772],0); -ELEMENTS[60967] = Fluid3D([18676,18641,18657,18647],0); -ELEMENTS[60968] = Fluid3D([16730,16586,16939,16453],0); -ELEMENTS[60969] = Fluid3D([2241,2374,2487,2615],0); -ELEMENTS[60970] = Fluid3D([16552,17019,16934,16723],0); -ELEMENTS[60971] = Fluid3D([17577,17295,17502,17156],0); -ELEMENTS[60972] = Fluid3D([16534,16881,16749,16356],0); -ELEMENTS[60973] = Fluid3D([16749,16534,16356,16391],0); -ELEMENTS[60974] = Fluid3D([17010,17191,17442,17131],0); -ELEMENTS[60975] = Fluid3D([17442,17010,17131,17276],0); -ELEMENTS[60976] = Fluid3D([5655,5956,5342,6109],0); -ELEMENTS[60977] = Fluid3D([5801,5190,5538,5452],0); -ELEMENTS[60978] = Fluid3D([5190,5538,5452,4953],0); -ELEMENTS[60979] = Fluid3D([5452,5190,4953,4635],0); -ELEMENTS[60980] = Fluid3D([7568,7488,8219,8365],0); -ELEMENTS[60981] = Fluid3D([8219,7568,8365,8049],0); -ELEMENTS[60982] = Fluid3D([7568,7488,8365,7966],0); -ELEMENTS[60983] = Fluid3D([8365,7568,7966,7425],0); -ELEMENTS[60984] = Fluid3D([6260,6315,7072,6429],0); -ELEMENTS[60985] = Fluid3D([16997,16878,17194,16555],0); -ELEMENTS[60986] = Fluid3D([16878,17194,16555,17081],0); -ELEMENTS[60987] = Fluid3D([16555,16878,17081,16762],0); -ELEMENTS[60988] = Fluid3D([16555,16878,16762,16160],0); -ELEMENTS[60989] = Fluid3D([7616,7922,7077,8208],0); -ELEMENTS[60990] = Fluid3D([14723,13932,14116,13992],0); -ELEMENTS[60991] = Fluid3D([11697,12351,12373,12119],0); -ELEMENTS[60992] = Fluid3D([17371,17538,17654,17256],0); -ELEMENTS[60993] = Fluid3D([17654,17371,17256,17508],0); -ELEMENTS[60994] = Fluid3D([17371,17538,17256,16965],0); -ELEMENTS[60995] = Fluid3D([17256,17371,16965,17144],0); -ELEMENTS[60996] = Fluid3D([16965,17256,17144,16810],0); -ELEMENTS[60997] = Fluid3D([17538,17654,17256,17457],0); -ELEMENTS[60998] = Fluid3D([17256,17538,17457,17172],0); -ELEMENTS[60999] = Fluid3D([17457,17256,17172,16810],0); -ELEMENTS[61000] = Fluid3D([17538,17256,16965,17172],0); -ELEMENTS[61001] = Fluid3D([17256,17371,17144,17508],0); -ELEMENTS[61002] = Fluid3D([17654,17256,17457,17144],0); -ELEMENTS[61003] = Fluid3D([17654,17256,17144,17508],0); -ELEMENTS[61004] = Fluid3D([17256,17457,17144,16810],0); -ELEMENTS[61005] = Fluid3D([2504,2264,2433,2578],0); -ELEMENTS[61006] = Fluid3D([2433,2504,2578,2771],0); -ELEMENTS[61007] = Fluid3D([16118,15734,15817,15598],0); -ELEMENTS[61008] = Fluid3D([15817,16118,15598,15915],0); -ELEMENTS[61009] = Fluid3D([15636,14923,15067,15344],0); -ELEMENTS[61010] = Fluid3D([6706,7424,6742,6969],0); -ELEMENTS[61011] = Fluid3D([18573,18453,18498,18532],0); -ELEMENTS[61012] = Fluid3D([18498,18573,18532,18579],0); -ELEMENTS[61013] = Fluid3D([18532,18498,18579,18503],0); -ELEMENTS[61014] = Fluid3D([13733,12787,13049,12976],0); -ELEMENTS[61015] = Fluid3D([8186,8146,7440,7221],0); -ELEMENTS[61016] = Fluid3D([18086,18168,18274,18063],0); -ELEMENTS[61017] = Fluid3D([16083,16442,15869,15885],0); -ELEMENTS[61018] = Fluid3D([15869,16083,15885,15404],0); -ELEMENTS[61019] = Fluid3D([15885,15869,15404,15641],0); -ELEMENTS[61020] = Fluid3D([16083,16442,15885,16154],0); -ELEMENTS[61021] = Fluid3D([15885,16083,16154,15239],0); -ELEMENTS[61022] = Fluid3D([13950,13344,14212,13226],0); -ELEMENTS[61023] = Fluid3D([8078,7789,7249,8347],0); -ELEMENTS[61024] = Fluid3D([10371,9386,10003,10266],0); -ELEMENTS[61025] = Fluid3D([15784,15236,15925,15549],0); -ELEMENTS[61026] = Fluid3D([5920,5334,5445,5414],0); -ELEMENTS[61027] = Fluid3D([18085,17881,18064,17908],0); -ELEMENTS[61028] = Fluid3D([18064,18085,17908,18236],0); -ELEMENTS[61029] = Fluid3D([18085,17881,17908,17915],0); -ELEMENTS[61030] = Fluid3D([18085,17908,18236,17977],0); -ELEMENTS[61031] = Fluid3D([18085,17908,17977,17715],0); -ELEMENTS[61032] = Fluid3D([17881,18064,17908,17775],0); -ELEMENTS[61033] = Fluid3D([18064,17908,17775,18123],0); -ELEMENTS[61034] = Fluid3D([17908,17881,17775,17537],0); -ELEMENTS[61035] = Fluid3D([17775,17908,17537,17786],0); -ELEMENTS[61036] = Fluid3D([17775,17908,17786,18123],0); -ELEMENTS[61037] = Fluid3D([17537,17775,17786,17408],0); -ELEMENTS[61038] = Fluid3D([13416,12497,13238,12176],0); -ELEMENTS[61039] = Fluid3D([15534,15560,15235,15620],0); -ELEMENTS[61040] = Fluid3D([15560,15235,15620,15176],0); -ELEMENTS[61041] = Fluid3D([15560,15235,15176,15242],0); -ELEMENTS[61042] = Fluid3D([15235,15620,15176,14990],0); -ELEMENTS[61043] = Fluid3D([10122,10490,9507,9376],0); -ELEMENTS[61044] = Fluid3D([13209,12722,12166,11925],0); -ELEMENTS[61045] = Fluid3D([2454,2676,2439,2734],0); -ELEMENTS[61046] = Fluid3D([7035,7072,7890,7602],0); -ELEMENTS[61047] = Fluid3D([16483,16653,16847,16242],0); -ELEMENTS[61048] = Fluid3D([13905,13678,14197,12936],0); -ELEMENTS[61049] = Fluid3D([8261,7470,7607,8426],0); -ELEMENTS[61050] = Fluid3D([7592,8390,8285,7679],0); -ELEMENTS[61051] = Fluid3D([17466,17233,17190,17018],0); -ELEMENTS[61052] = Fluid3D([17466,17233,17018,16931],0); -ELEMENTS[61053] = Fluid3D([17233,17018,16931,16738],0); -ELEMENTS[61054] = Fluid3D([17018,16931,16738,16612],0); -ELEMENTS[61055] = Fluid3D([17233,17018,16738,17190],0); -ELEMENTS[61056] = Fluid3D([17190,17466,17018,17178],0); -ELEMENTS[61057] = Fluid3D([17018,17466,16931,17178],0); -ELEMENTS[61058] = Fluid3D([16931,17018,17178,16876],0); -ELEMENTS[61059] = Fluid3D([17018,17178,16876,17190],0); -ELEMENTS[61060] = Fluid3D([16931,17018,16876,16612],0); -ELEMENTS[61061] = Fluid3D([17018,16876,16612,17190],0); -ELEMENTS[61062] = Fluid3D([16738,17018,16612,17190],0); -ELEMENTS[61063] = Fluid3D([9404,8636,8576,8886],0); -ELEMENTS[61064] = Fluid3D([4644,4524,5139,4479],0); -ELEMENTS[61065] = Fluid3D([2431,2314,2204,2503],0); -ELEMENTS[61066] = Fluid3D([6907,7168,7718,7269],0); -ELEMENTS[61067] = Fluid3D([10441,9870,10888,10998],0); -ELEMENTS[61068] = Fluid3D([7267,7652,8374,8201],0); -ELEMENTS[61069] = Fluid3D([12547,11587,12148,12191],0); -ELEMENTS[61070] = Fluid3D([12547,11587,12191,12160],0); -ELEMENTS[61071] = Fluid3D([13521,13971,13205,14322],0); -ELEMENTS[61072] = Fluid3D([14792,15227,14928,14429],0); -ELEMENTS[61073] = Fluid3D([14792,15227,14429,15102],0); -ELEMENTS[61074] = Fluid3D([13801,13679,13299,12887],0); -ELEMENTS[61075] = Fluid3D([14817,14912,15471,14825],0); -ELEMENTS[61076] = Fluid3D([5604,5032,5191,5916],0); -ELEMENTS[61077] = Fluid3D([18481,18352,18448,18344],0); -ELEMENTS[61078] = Fluid3D([9540,8861,8631,9258],0); -ELEMENTS[61079] = Fluid3D([15266,15601,15207,15025],0); -ELEMENTS[61080] = Fluid3D([10573,10250,9604,9950],0); -ELEMENTS[61081] = Fluid3D([4263,4376,4751,4507],0); -ELEMENTS[61082] = Fluid3D([17472,17436,17197,17088],0); -ELEMENTS[61083] = Fluid3D([17472,17436,17088,17696],0); -ELEMENTS[61084] = Fluid3D([17436,17197,17088,17167],0); -ELEMENTS[61085] = Fluid3D([17197,17472,17088,16818],0); -ELEMENTS[61086] = Fluid3D([17088,17197,16818,16678],0); -ELEMENTS[61087] = Fluid3D([16818,17088,16678,16752],0); -ELEMENTS[61088] = Fluid3D([17567,17270,17675,17462],0); -ELEMENTS[61089] = Fluid3D([4345,4036,3949,4141],0); -ELEMENTS[61090] = Fluid3D([4345,4036,4141,4589],0); -ELEMENTS[61091] = Fluid3D([16651,16291,16478,16034],0); -ELEMENTS[61092] = Fluid3D([17700,17939,18005,17676],0); -ELEMENTS[61093] = Fluid3D([18005,17700,17676,17751],0); -ELEMENTS[61094] = Fluid3D([17700,17939,17676,17677],0); -ELEMENTS[61095] = Fluid3D([17700,17676,17751,17393],0); -ELEMENTS[61096] = Fluid3D([17700,17676,17393,17254],0); -ELEMENTS[61097] = Fluid3D([17676,17751,17393,17378],0); -ELEMENTS[61098] = Fluid3D([17676,17393,17254,17495],0); -ELEMENTS[61099] = Fluid3D([17676,17393,17495,17378],0); -ELEMENTS[61100] = Fluid3D([17393,17254,17495,16976],0); -ELEMENTS[61101] = Fluid3D([17939,18005,17676,17677],0); -ELEMENTS[61102] = Fluid3D([17676,17700,17677,17254],0); -ELEMENTS[61103] = Fluid3D([2886,2595,2723,2944],0); -ELEMENTS[61104] = Fluid3D([11137,11803,10827,11133],0); -ELEMENTS[61105] = Fluid3D([15460,15750,15330,15052],0); -ELEMENTS[61106] = Fluid3D([10482,10712,11557,10960],0); -ELEMENTS[61107] = Fluid3D([13977,14295,14473,13602],0); -ELEMENTS[61108] = Fluid3D([8608,8711,8379,9776],0); -ELEMENTS[61109] = Fluid3D([13151,13201,13945,13120],0); -ELEMENTS[61110] = Fluid3D([13945,13151,13120,12930],0); -ELEMENTS[61111] = Fluid3D([13151,13120,12930,12521],0); -ELEMENTS[61112] = Fluid3D([13120,12930,12521,13541],0); -ELEMENTS[61113] = Fluid3D([13120,12930,13541,13945],0); -ELEMENTS[61114] = Fluid3D([12521,13120,13541,13628],0); -ELEMENTS[61115] = Fluid3D([13120,13541,13628,13945],0); -ELEMENTS[61116] = Fluid3D([12521,13120,13628,13201],0); -ELEMENTS[61117] = Fluid3D([12521,13120,13201,13151],0); -ELEMENTS[61118] = Fluid3D([13201,13945,13120,13628],0); -ELEMENTS[61119] = Fluid3D([12930,12521,13541,12277],0); -ELEMENTS[61120] = Fluid3D([3393,3593,3193,3460],0); -ELEMENTS[61121] = Fluid3D([18680,18661,18684,18625],0); -ELEMENTS[61122] = Fluid3D([18265,18089,18115,17935],0); -ELEMENTS[61123] = Fluid3D([18089,18115,17935,17918],0); -ELEMENTS[61124] = Fluid3D([18115,18265,17935,18135],0); -ELEMENTS[61125] = Fluid3D([3508,3429,3142,3566],0); -ELEMENTS[61126] = Fluid3D([3142,3508,3566,3430],0); -ELEMENTS[61127] = Fluid3D([3566,3142,3430,3209],0); -ELEMENTS[61128] = Fluid3D([3430,3566,3209,3743],0); -ELEMENTS[61129] = Fluid3D([3508,3566,3430,3878],0); -ELEMENTS[61130] = Fluid3D([3566,3430,3878,3743],0); -ELEMENTS[61131] = Fluid3D([3508,3566,3878,3429],0); -ELEMENTS[61132] = Fluid3D([3566,3878,3429,3533],0); -ELEMENTS[61133] = Fluid3D([3566,3878,3533,3520],0); -ELEMENTS[61134] = Fluid3D([3429,3566,3533,3142],0); -ELEMENTS[61135] = Fluid3D([3533,3566,3520,3209],0); -ELEMENTS[61136] = Fluid3D([3566,3533,3142,3209],0); -ELEMENTS[61137] = Fluid3D([13950,14765,14519,14145],0); -ELEMENTS[61138] = Fluid3D([17300,16993,17145,16601],0); -ELEMENTS[61139] = Fluid3D([15153,14586,14502,15169],0); -ELEMENTS[61140] = Fluid3D([6121,5629,5527,5957],0); -ELEMENTS[61141] = Fluid3D([5629,5527,5957,5079],0); -ELEMENTS[61142] = Fluid3D([6121,5629,5957,6245],0); -ELEMENTS[61143] = Fluid3D([17194,17486,17302,17075],0); -ELEMENTS[61144] = Fluid3D([17194,17486,17075,17386],0); -ELEMENTS[61145] = Fluid3D([16090,15447,15752,15656],0); -ELEMENTS[61146] = Fluid3D([2027,2130,1961,2188],0); -ELEMENTS[61147] = Fluid3D([2130,1961,2188,2054],0); -ELEMENTS[61148] = Fluid3D([5068,4741,5603,5331],0); -ELEMENTS[61149] = Fluid3D([4876,5146,5439,5650],0); -ELEMENTS[61150] = Fluid3D([13728,12838,13162,13567],0); -ELEMENTS[61151] = Fluid3D([13728,12838,13567,13426],0); -ELEMENTS[61152] = Fluid3D([14120,14444,14699,13827],0); -ELEMENTS[61153] = Fluid3D([10732,9814,9900,9772],0); -ELEMENTS[61154] = Fluid3D([9900,10732,9772,9996],0); -ELEMENTS[61155] = Fluid3D([9772,9900,9996,8995],0); -ELEMENTS[61156] = Fluid3D([9814,9900,9772,8995],0); -ELEMENTS[61157] = Fluid3D([10732,9814,9772,10619],0); -ELEMENTS[61158] = Fluid3D([10732,9772,9996,10437],0); -ELEMENTS[61159] = Fluid3D([9772,9996,10437,9139],0); -ELEMENTS[61160] = Fluid3D([10732,9772,10437,10619],0); -ELEMENTS[61161] = Fluid3D([9772,9996,9139,8995],0); -ELEMENTS[61162] = Fluid3D([15028,14737,15190,14112],0); -ELEMENTS[61163] = Fluid3D([5026,5157,4593,4973],0); -ELEMENTS[61164] = Fluid3D([16858,16736,16501,15927],0); -ELEMENTS[61165] = Fluid3D([4220,4189,4722,4344],0); -ELEMENTS[61166] = Fluid3D([4722,4220,4344,4693],0); -ELEMENTS[61167] = Fluid3D([4189,4722,4344,4363],0); -ELEMENTS[61168] = Fluid3D([4344,4189,4363,3950],0); -ELEMENTS[61169] = Fluid3D([4363,4344,3950,4669],0); -ELEMENTS[61170] = Fluid3D([4363,4344,4669,5109],0); -ELEMENTS[61171] = Fluid3D([4220,4189,4344,3737],0); -ELEMENTS[61172] = Fluid3D([4722,4344,4363,5109],0); -ELEMENTS[61173] = Fluid3D([5349,5667,5885,5926],0); -ELEMENTS[61174] = Fluid3D([15342,15262,15663,14951],0); -ELEMENTS[61175] = Fluid3D([15262,15663,14951,15077],0); -ELEMENTS[61176] = Fluid3D([15663,14951,15077,15476],0); -ELEMENTS[61177] = Fluid3D([14951,15262,15077,14374],0); -ELEMENTS[61178] = Fluid3D([15077,14951,14374,14358],0); -ELEMENTS[61179] = Fluid3D([15077,14951,14358,14816],0); -ELEMENTS[61180] = Fluid3D([15342,15262,14951,14521],0); -ELEMENTS[61181] = Fluid3D([14951,15342,14521,14883],0); -ELEMENTS[61182] = Fluid3D([14521,14951,14883,14358],0); -ELEMENTS[61183] = Fluid3D([14951,15342,14883,15663],0); -ELEMENTS[61184] = Fluid3D([15262,14951,14521,14374],0); -ELEMENTS[61185] = Fluid3D([14951,14521,14374,14358],0); -ELEMENTS[61186] = Fluid3D([5221,4703,4781,4754],0); -ELEMENTS[61187] = Fluid3D([18149,18317,18175,18075],0); -ELEMENTS[61188] = Fluid3D([14729,14123,14980,14614],0); -ELEMENTS[61189] = Fluid3D([9757,8853,9056,8675],0); -ELEMENTS[61190] = Fluid3D([17946,17608,17638,17591],0); -ELEMENTS[61191] = Fluid3D([12989,13398,13958,13084],0); -ELEMENTS[61192] = Fluid3D([3075,3024,2777,3247],0); -ELEMENTS[61193] = Fluid3D([4620,4452,4843,4840],0); -ELEMENTS[61194] = Fluid3D([4452,4843,4840,4193],0); -ELEMENTS[61195] = Fluid3D([4620,4452,4840,3957],0); -ELEMENTS[61196] = Fluid3D([15894,15469,15708,15038],0); -ELEMENTS[61197] = Fluid3D([10702,9693,9764,10137],0); -ELEMENTS[61198] = Fluid3D([9764,10702,10137,9892],0); -ELEMENTS[61199] = Fluid3D([10137,9764,9892,9091],0); -ELEMENTS[61200] = Fluid3D([9693,9764,10137,8805],0); -ELEMENTS[61201] = Fluid3D([10702,9693,10137,11008],0); -ELEMENTS[61202] = Fluid3D([10137,10702,11008,11203],0); -ELEMENTS[61203] = Fluid3D([10702,11008,11203,11914],0); -ELEMENTS[61204] = Fluid3D([11008,11203,11914,11120],0); -ELEMENTS[61205] = Fluid3D([11008,11203,11120,10137],0); -ELEMENTS[61206] = Fluid3D([11914,11008,11120,11880],0); -ELEMENTS[61207] = Fluid3D([11766,11072,12401,11369],0); -ELEMENTS[61208] = Fluid3D([11766,11072,11369,10912],0); -ELEMENTS[61209] = Fluid3D([11365,12264,11537,11839],0); -ELEMENTS[61210] = Fluid3D([16585,16986,16516,16800],0); -ELEMENTS[61211] = Fluid3D([17819,17723,17559,17468],0); -ELEMENTS[61212] = Fluid3D([17819,17723,17468,17610],0); -ELEMENTS[61213] = Fluid3D([17559,17819,17468,17301],0); -ELEMENTS[61214] = Fluid3D([17468,17559,17301,17183],0); -ELEMENTS[61215] = Fluid3D([17301,17468,17183,17105],0); -ELEMENTS[61216] = Fluid3D([17559,17301,17183,17262],0); -ELEMENTS[61217] = Fluid3D([17468,17559,17183,17723],0); -ELEMENTS[61218] = Fluid3D([17723,17468,17610,17339],0); -ELEMENTS[61219] = Fluid3D([17468,17610,17339,17754],0); -ELEMENTS[61220] = Fluid3D([17723,17468,17339,17183],0); -ELEMENTS[61221] = Fluid3D([17468,17339,17183,17105],0); -ELEMENTS[61222] = Fluid3D([17610,17723,17339,17639],0); -ELEMENTS[61223] = Fluid3D([1879,2080,1931,1913],0); -ELEMENTS[61224] = Fluid3D([2312,2561,2431,2463],0); -ELEMENTS[61225] = Fluid3D([13871,13539,14343,13660],0); -ELEMENTS[61226] = Fluid3D([12590,12243,11634,12250],0); -ELEMENTS[61227] = Fluid3D([14242,13918,14418,13780],0); -ELEMENTS[61228] = Fluid3D([9105,10108,9967,10121],0); -ELEMENTS[61229] = Fluid3D([4280,3933,4290,4769],0); -ELEMENTS[61230] = Fluid3D([5008,4472,4657,4845],0); -ELEMENTS[61231] = Fluid3D([8847,9875,9637,9279],0); -ELEMENTS[61232] = Fluid3D([9809,9517,10361,9688],0); -ELEMENTS[61233] = Fluid3D([9809,9517,9688,8819],0); -ELEMENTS[61234] = Fluid3D([9517,10361,9688,9374],0); -ELEMENTS[61235] = Fluid3D([3637,3468,3238,3678],0); -ELEMENTS[61236] = Fluid3D([3637,3468,3678,3884],0); -ELEMENTS[61237] = Fluid3D([3468,3238,3678,3094],0); -ELEMENTS[61238] = Fluid3D([18494,18465,18369,18288],0); -ELEMENTS[61239] = Fluid3D([16526,16153,16353,15642],0); -ELEMENTS[61240] = Fluid3D([4725,4417,4216,4654],0); -ELEMENTS[61241] = Fluid3D([4216,4725,4654,4522],0); -ELEMENTS[61242] = Fluid3D([4654,4216,4522,4156],0); -ELEMENTS[61243] = Fluid3D([4654,4216,4156,4294],0); -ELEMENTS[61244] = Fluid3D([4654,4216,4294,4417],0); -ELEMENTS[61245] = Fluid3D([4725,4654,4522,5103],0); -ELEMENTS[61246] = Fluid3D([11420,11798,12492,11855],0); -ELEMENTS[61247] = Fluid3D([3928,3962,3579,4142],0); -ELEMENTS[61248] = Fluid3D([15980,16344,16047,15898],0); -ELEMENTS[61249] = Fluid3D([16344,16047,15898,16398],0); -ELEMENTS[61250] = Fluid3D([18624,18562,18589,18502],0); -ELEMENTS[61251] = Fluid3D([3040,3193,3409,3527],0); -ELEMENTS[61252] = Fluid3D([9188,8293,8583,7825],0); -ELEMENTS[61253] = Fluid3D([17928,17551,17685,17630],0); -ELEMENTS[61254] = Fluid3D([16062,15917,16310,15445],0); -ELEMENTS[61255] = Fluid3D([17510,17617,17566,17215],0); -ELEMENTS[61256] = Fluid3D([14766,14173,13984,13893],0); -ELEMENTS[61257] = Fluid3D([15077,14958,14085,14374],0); -ELEMENTS[61258] = Fluid3D([8340,9341,9082,8883],0); -ELEMENTS[61259] = Fluid3D([9082,8340,8883,8093],0); -ELEMENTS[61260] = Fluid3D([2415,2605,2366,2717],0); -ELEMENTS[61261] = Fluid3D([17238,17111,17418,16963],0); -ELEMENTS[61262] = Fluid3D([17579,17713,17440,17226],0); -ELEMENTS[61263] = Fluid3D([13542,12809,13783,13775],0); -ELEMENTS[61264] = Fluid3D([5341,5760,5163,4888],0); -ELEMENTS[61265] = Fluid3D([5163,5341,4888,4773],0); -ELEMENTS[61266] = Fluid3D([5341,4888,4773,4886],0); -ELEMENTS[61267] = Fluid3D([17837,17669,17577,17426],0); -ELEMENTS[61268] = Fluid3D([18316,18446,18424,18298],0); -ELEMENTS[61269] = Fluid3D([12456,11845,12796,12406],0); -ELEMENTS[61270] = Fluid3D([12796,12456,12406,13360],0); -ELEMENTS[61271] = Fluid3D([12456,12406,13360,13056],0); -ELEMENTS[61272] = Fluid3D([3523,3435,3835,3911],0); -ELEMENTS[61273] = Fluid3D([15521,15711,15941,15441],0); -ELEMENTS[61274] = Fluid3D([15711,15941,15441,16114],0); -ELEMENTS[61275] = Fluid3D([3752,3376,3673,3666],0); -ELEMENTS[61276] = Fluid3D([3376,3673,3666,3300],0); -ELEMENTS[61277] = Fluid3D([12362,12885,12598,11719],0); -ELEMENTS[61278] = Fluid3D([6726,7161,6228,6894],0); -ELEMENTS[61279] = Fluid3D([7756,6928,7417,7990],0); -ELEMENTS[61280] = Fluid3D([2558,2368,2320,2568],0); -ELEMENTS[61281] = Fluid3D([14984,15418,15335,14676],0); -ELEMENTS[61282] = Fluid3D([10326,9262,10110,10309],0); -ELEMENTS[61283] = Fluid3D([17774,17984,17651,17612],0); -ELEMENTS[61284] = Fluid3D([10092,10386,10782,10370],0); -ELEMENTS[61285] = Fluid3D([13378,13132,12862,12293],0); -ELEMENTS[61286] = Fluid3D([8776,8840,9590,8492],0); -ELEMENTS[61287] = Fluid3D([4497,4324,4737,4091],0); -ELEMENTS[61288] = Fluid3D([16600,16067,16108,16194],0); -ELEMENTS[61289] = Fluid3D([15506,15246,14735,15109],0); -ELEMENTS[61290] = Fluid3D([17878,17984,18164,17945],0); -ELEMENTS[61291] = Fluid3D([17878,17984,17945,17651],0); -ELEMENTS[61292] = Fluid3D([17984,18164,17945,18151],0); -ELEMENTS[61293] = Fluid3D([15265,15065,14519,14580],0); -ELEMENTS[61294] = Fluid3D([9604,9297,8664,9950],0); -ELEMENTS[61295] = Fluid3D([18521,18448,18409,18348],0); -ELEMENTS[61296] = Fluid3D([18409,18521,18348,18355],0); -ELEMENTS[61297] = Fluid3D([13406,13826,12746,13316],0); -ELEMENTS[61298] = Fluid3D([12746,13406,13316,12696],0); -ELEMENTS[61299] = Fluid3D([12746,13406,12696,12962],0); -ELEMENTS[61300] = Fluid3D([11826,11960,11468,10669],0); -ELEMENTS[61301] = Fluid3D([6584,5948,6022,6815],0); -ELEMENTS[61302] = Fluid3D([15059,15447,14736,14864],0); -ELEMENTS[61303] = Fluid3D([16068,16444,16611,16874],0); -ELEMENTS[61304] = Fluid3D([5708,5785,6395,5967],0); -ELEMENTS[61305] = Fluid3D([3623,3300,3250,3548],0); -ELEMENTS[61306] = Fluid3D([12598,12885,13115,12107],0); -ELEMENTS[61307] = Fluid3D([7590,8289,7882,6889],0); -ELEMENTS[61308] = Fluid3D([2213,2500,2266,2287],0); -ELEMENTS[61309] = Fluid3D([18469,18562,18538,18421],0); -ELEMENTS[61310] = Fluid3D([9065,9641,8709,9401],0); -ELEMENTS[61311] = Fluid3D([8709,9065,9401,8158],0); -ELEMENTS[61312] = Fluid3D([7718,8293,7453,7269],0); -ELEMENTS[61313] = Fluid3D([9594,8642,9184,9725],0); -ELEMENTS[61314] = Fluid3D([18256,18150,18066,17834],0); -ELEMENTS[61315] = Fluid3D([13679,13595,13191,12901],0); -ELEMENTS[61316] = Fluid3D([3376,3020,3300,3331],0); -ELEMENTS[61317] = Fluid3D([16168,15917,15785,15496],0); -ELEMENTS[61318] = Fluid3D([12439,13201,12375,12025],0); -ELEMENTS[61319] = Fluid3D([12375,12439,12025,11563],0); -ELEMENTS[61320] = Fluid3D([12025,12375,11563,11513],0); -ELEMENTS[61321] = Fluid3D([13201,12375,12025,13151],0); -ELEMENTS[61322] = Fluid3D([3333,3676,3687,3794],0); -ELEMENTS[61323] = Fluid3D([12975,13386,13831,14054],0); -ELEMENTS[61324] = Fluid3D([15138,15571,15510,15039],0); -ELEMENTS[61325] = Fluid3D([15050,15278,15782,15298],0); -ELEMENTS[61326] = Fluid3D([18530,18605,18539,18416],0); -ELEMENTS[61327] = Fluid3D([18539,18530,18416,18449],0); -ELEMENTS[61328] = Fluid3D([7551,8418,8020,7581],0); -ELEMENTS[61329] = Fluid3D([3098,3080,3444,3669],0); -ELEMENTS[61330] = Fluid3D([2317,2556,2511,2751],0); -ELEMENTS[61331] = Fluid3D([2556,2511,2751,2777],0); -ELEMENTS[61332] = Fluid3D([17642,17413,17665,17102],0); -ELEMENTS[61333] = Fluid3D([17327,17153,17015,16702],0); -ELEMENTS[61334] = Fluid3D([17302,16997,17194,16725],0); -ELEMENTS[61335] = Fluid3D([16676,16795,17191,17084],0); -ELEMENTS[61336] = Fluid3D([17124,17106,17376,16910],0); -ELEMENTS[61337] = Fluid3D([1978,2144,2058,2211],0); -ELEMENTS[61338] = Fluid3D([17870,17644,18046,17928],0); -ELEMENTS[61339] = Fluid3D([17774,17893,18084,17894],0); -ELEMENTS[61340] = Fluid3D([18084,17774,17894,17984],0); -ELEMENTS[61341] = Fluid3D([17894,18084,17984,18151],0); -ELEMENTS[61342] = Fluid3D([17894,18084,18151,18193],0); -ELEMENTS[61343] = Fluid3D([4782,4978,4516,5168],0); -ELEMENTS[61344] = Fluid3D([13056,12743,12117,11813],0); -ELEMENTS[61345] = Fluid3D([5594,6223,5989,6449],0); -ELEMENTS[61346] = Fluid3D([16269,15883,16026,15295],0); -ELEMENTS[61347] = Fluid3D([1729,1659,1639,1727],0); -ELEMENTS[61348] = Fluid3D([7339,8169,7955,8187],0); -ELEMENTS[61349] = Fluid3D([7339,8169,8187,7569],0); -ELEMENTS[61350] = Fluid3D([8169,7955,8187,8996],0); -ELEMENTS[61351] = Fluid3D([9981,9757,9056,9411],0); -ELEMENTS[61352] = Fluid3D([12492,12150,11420,11855],0); -ELEMENTS[61353] = Fluid3D([18589,18610,18641,18565],0); -ELEMENTS[61354] = Fluid3D([17696,17888,17665,17550],0); -ELEMENTS[61355] = Fluid3D([2955,2699,2989,3140],0); -ELEMENTS[61356] = Fluid3D([15539,15807,16305,16089],0); -ELEMENTS[61357] = Fluid3D([8853,8008,8179,7429],0); -ELEMENTS[61358] = Fluid3D([3296,3044,3109,3072],0); -ELEMENTS[61359] = Fluid3D([3296,3044,3072,2948],0); -ELEMENTS[61360] = Fluid3D([6680,7468,6830,7669],0); -ELEMENTS[61361] = Fluid3D([18582,18521,18497,18486],0); -ELEMENTS[61362] = Fluid3D([12031,12590,11634,12193],0); -ELEMENTS[61363] = Fluid3D([13618,13918,13417,12575],0); -ELEMENTS[61364] = Fluid3D([8288,8149,7371,8043],0); -ELEMENTS[61365] = Fluid3D([18394,18481,18517,18370],0); -ELEMENTS[61366] = Fluid3D([16146,16561,16045,16404],0); -ELEMENTS[61367] = Fluid3D([16146,16561,16404,16741],0); -ELEMENTS[61368] = Fluid3D([16561,16045,16404,16370],0); -ELEMENTS[61369] = Fluid3D([13202,13314,12832,12324],0); -ELEMENTS[61370] = Fluid3D([10661,11599,10822,11435],0); -ELEMENTS[61371] = Fluid3D([11599,10822,11435,12094],0); -ELEMENTS[61372] = Fluid3D([11435,11599,12094,11960],0); -ELEMENTS[61373] = Fluid3D([12094,11435,11960,10795],0); -ELEMENTS[61374] = Fluid3D([11435,11599,11960,10661],0); -ELEMENTS[61375] = Fluid3D([12094,11435,10795,10822],0); -ELEMENTS[61376] = Fluid3D([11435,10795,10822,10661],0); -ELEMENTS[61377] = Fluid3D([11435,10795,10661,11960],0); -ELEMENTS[61378] = Fluid3D([18404,18255,18300,18182],0); -ELEMENTS[61379] = Fluid3D([5475,5958,5994,5545],0); -ELEMENTS[61380] = Fluid3D([5958,5994,5545,6319],0); -ELEMENTS[61381] = Fluid3D([5958,5994,6319,6097],0); -ELEMENTS[61382] = Fluid3D([5545,5958,6319,5855],0); -ELEMENTS[61383] = Fluid3D([5994,5545,6319,6203],0); -ELEMENTS[61384] = Fluid3D([6319,5994,6203,6768],0); -ELEMENTS[61385] = Fluid3D([6319,5994,6768,6097],0); -ELEMENTS[61386] = Fluid3D([10314,10695,11420,10875],0); -ELEMENTS[61387] = Fluid3D([17500,17532,17406,17080],0); -ELEMENTS[61388] = Fluid3D([2254,2498,2391,2518],0); -ELEMENTS[61389] = Fluid3D([15698,15448,14999,15239],0); -ELEMENTS[61390] = Fluid3D([10371,11011,11375,10803],0); -ELEMENTS[61391] = Fluid3D([10371,11011,10803,10003],0); -ELEMENTS[61392] = Fluid3D([11375,10371,10803,11675],0); -ELEMENTS[61393] = Fluid3D([10803,10371,10003,10266],0); -ELEMENTS[61394] = Fluid3D([10803,10371,10266,9943],0); -ELEMENTS[61395] = Fluid3D([15912,15512,15623,15584],0); -ELEMENTS[61396] = Fluid3D([16390,15925,16522,16506],0); -ELEMENTS[61397] = Fluid3D([1964,2124,1995,2109],0); -ELEMENTS[61398] = Fluid3D([12139,11418,12363,12798],0); -ELEMENTS[61399] = Fluid3D([18261,18236,18381,18133],0); -ELEMENTS[61400] = Fluid3D([14750,14073,14817,14276],0); -ELEMENTS[61401] = Fluid3D([14073,14817,14276,14250],0); -ELEMENTS[61402] = Fluid3D([14817,14276,14250,14517],0); -ELEMENTS[61403] = Fluid3D([14817,14276,14517,14694],0); -ELEMENTS[61404] = Fluid3D([14276,14517,14694,14428],0); -ELEMENTS[61405] = Fluid3D([14276,14517,14428,13648],0); -ELEMENTS[61406] = Fluid3D([14694,14276,14428,13648],0); -ELEMENTS[61407] = Fluid3D([14694,14276,13648,14750],0); -ELEMENTS[61408] = Fluid3D([14694,14276,14750,14817],0); -ELEMENTS[61409] = Fluid3D([14276,14517,13648,14250],0); -ELEMENTS[61410] = Fluid3D([14750,14073,14276,13648],0); -ELEMENTS[61411] = Fluid3D([14073,14276,13648,14250],0); -ELEMENTS[61412] = Fluid3D([13166,14123,13837,13881],0); -ELEMENTS[61413] = Fluid3D([14123,13837,13881,14729],0); -ELEMENTS[61414] = Fluid3D([13166,14123,13881,13505],0); -ELEMENTS[61415] = Fluid3D([18422,18360,18274,18207],0); -ELEMENTS[61416] = Fluid3D([4504,4274,4784,4912],0); -ELEMENTS[61417] = Fluid3D([16135,15928,15831,15281],0); -ELEMENTS[61418] = Fluid3D([9074,8997,9368,8478],0); -ELEMENTS[61419] = Fluid3D([13422,12583,13245,12501],0); -ELEMENTS[61420] = Fluid3D([12300,11485,12463,11385],0); -ELEMENTS[61421] = Fluid3D([8988,9871,9738,10271],0); -ELEMENTS[61422] = Fluid3D([4078,4469,4562,4190],0); -ELEMENTS[61423] = Fluid3D([4430,4524,3979,4479],0); -ELEMENTS[61424] = Fluid3D([4430,4524,4479,4949],0); -ELEMENTS[61425] = Fluid3D([4524,4479,4949,5139],0); -ELEMENTS[61426] = Fluid3D([15662,16144,15554,15741],0); -ELEMENTS[61427] = Fluid3D([10797,10319,9791,10728],0); -ELEMENTS[61428] = Fluid3D([13082,12547,12148,12815],0); -ELEMENTS[61429] = Fluid3D([12547,12148,12815,12191],0); -ELEMENTS[61430] = Fluid3D([12815,12547,12191,13400],0); -ELEMENTS[61431] = Fluid3D([13082,12547,12815,13491],0); -ELEMENTS[61432] = Fluid3D([12148,13082,12815,13461],0); -ELEMENTS[61433] = Fluid3D([13082,12815,13461,13600],0); -ELEMENTS[61434] = Fluid3D([13461,13082,13600,13962],0); -ELEMENTS[61435] = Fluid3D([12815,13461,13600,13982],0); -ELEMENTS[61436] = Fluid3D([13461,13600,13982,14243],0); -ELEMENTS[61437] = Fluid3D([13600,13982,14243,13491],0); -ELEMENTS[61438] = Fluid3D([13461,13600,14243,13962],0); -ELEMENTS[61439] = Fluid3D([13600,14243,13962,13491],0); -ELEMENTS[61440] = Fluid3D([13600,13982,13491,13400],0); -ELEMENTS[61441] = Fluid3D([13600,13982,13400,12815],0); -ELEMENTS[61442] = Fluid3D([13082,12815,13600,13491],0); -ELEMENTS[61443] = Fluid3D([13600,13082,13491,13962],0); -ELEMENTS[61444] = Fluid3D([17173,17505,17041,17066],0); -ELEMENTS[61445] = Fluid3D([16930,16728,16463,17212],0); -ELEMENTS[61446] = Fluid3D([10570,11219,9785,10303],0); -ELEMENTS[61447] = Fluid3D([17235,17197,16955,16818],0); -ELEMENTS[61448] = Fluid3D([15114,15337,15551,14582],0); -ELEMENTS[61449] = Fluid3D([16329,16111,15932,15859],0); -ELEMENTS[61450] = Fluid3D([10220,10030,9290,10605],0); -ELEMENTS[61451] = Fluid3D([3656,3886,4092,4306],0); -ELEMENTS[61452] = Fluid3D([16813,17115,17047,16673],0); -ELEMENTS[61453] = Fluid3D([5454,4929,4834,5329],0); -ELEMENTS[61454] = Fluid3D([16952,17042,17370,16982],0); -ELEMENTS[61455] = Fluid3D([6294,6450,7126,6073],0); -ELEMENTS[61456] = Fluid3D([12977,13718,14103,13349],0); -ELEMENTS[61457] = Fluid3D([16402,16575,16961,16652],0); -ELEMENTS[61458] = Fluid3D([14782,14295,14605,13866],0); -ELEMENTS[61459] = Fluid3D([11713,12209,11162,11789],0); -ELEMENTS[61460] = Fluid3D([12328,13151,13124,12835],0); -ELEMENTS[61461] = Fluid3D([16541,16044,16187,16159],0); -ELEMENTS[61462] = Fluid3D([3230,3142,2888,3430],0); -ELEMENTS[61463] = Fluid3D([3230,3142,3430,3508],0); -ELEMENTS[61464] = Fluid3D([15265,14765,15451,14885],0); -ELEMENTS[61465] = Fluid3D([14765,15451,14885,14977],0); -ELEMENTS[61466] = Fluid3D([5578,6133,5426,5812],0); -ELEMENTS[61467] = Fluid3D([8269,8748,9366,8773],0); -ELEMENTS[61468] = Fluid3D([15370,14994,15882,15739],0); -ELEMENTS[61469] = Fluid3D([18465,18540,18446,18397],0); -ELEMENTS[61470] = Fluid3D([13420,12946,13834,13329],0); -ELEMENTS[61471] = Fluid3D([14038,13520,14347,14719],0); -ELEMENTS[61472] = Fluid3D([8805,7958,8876,8535],0); -ELEMENTS[61473] = Fluid3D([7958,8876,8535,8934],0); -ELEMENTS[61474] = Fluid3D([8876,8535,8934,9091],0); -ELEMENTS[61475] = Fluid3D([8535,8934,9091,7983],0); -ELEMENTS[61476] = Fluid3D([9091,8535,7983,8473],0); -ELEMENTS[61477] = Fluid3D([8535,8934,7983,7958],0); -ELEMENTS[61478] = Fluid3D([7983,8535,7958,8805],0); -ELEMENTS[61479] = Fluid3D([8535,7983,8473,8805],0); -ELEMENTS[61480] = Fluid3D([9091,8535,8473,8805],0); -ELEMENTS[61481] = Fluid3D([8876,8805,8535,9091],0); -ELEMENTS[61482] = Fluid3D([12033,12760,11867,11581],0); -ELEMENTS[61483] = Fluid3D([13039,13524,13104,12416],0); -ELEMENTS[61484] = Fluid3D([2207,2072,2028,2221],0); -ELEMENTS[61485] = Fluid3D([2207,2072,2221,2350],0); -ELEMENTS[61486] = Fluid3D([2028,2207,2221,2310],0); -ELEMENTS[61487] = Fluid3D([2207,2221,2310,2350],0); -ELEMENTS[61488] = Fluid3D([2221,2310,2350,2193],0); -ELEMENTS[61489] = Fluid3D([2221,2310,2193,2126],0); -ELEMENTS[61490] = Fluid3D([2221,2310,2126,2028],0); -ELEMENTS[61491] = Fluid3D([2350,2221,2193,2072],0); -ELEMENTS[61492] = Fluid3D([2126,2221,2028,2193],0); -ELEMENTS[61493] = Fluid3D([2221,2193,2072,2028],0); -ELEMENTS[61494] = Fluid3D([13980,14385,13931,13090],0); -ELEMENTS[61495] = Fluid3D([9646,8929,8469,9069],0); -ELEMENTS[61496] = Fluid3D([14698,14982,15220,15324],0); -ELEMENTS[61497] = Fluid3D([12684,13184,12343,12875],0); -ELEMENTS[61498] = Fluid3D([15920,16224,15597,15573],0); -ELEMENTS[61499] = Fluid3D([8709,8385,7811,8734],0); -ELEMENTS[61500] = Fluid3D([13706,13086,13950,12916],0); -ELEMENTS[61501] = Fluid3D([2594,2727,2518,2948],0); -ELEMENTS[61502] = Fluid3D([14175,14644,14532,13807],0); -ELEMENTS[61503] = Fluid3D([12153,12528,11839,11537],0); -ELEMENTS[61504] = Fluid3D([12153,12528,11537,11701],0); -ELEMENTS[61505] = Fluid3D([5529,4985,5072,5282],0); -ELEMENTS[61506] = Fluid3D([4985,5072,5282,5125],0); -ELEMENTS[61507] = Fluid3D([5072,5282,5125,5729],0); -ELEMENTS[61508] = Fluid3D([5282,4985,5125,4478],0); -ELEMENTS[61509] = Fluid3D([5529,4985,5282,5433],0); -ELEMENTS[61510] = Fluid3D([9011,9603,10153,10313],0); -ELEMENTS[61511] = Fluid3D([5918,5324,5767,6102],0); -ELEMENTS[61512] = Fluid3D([8467,8094,8231,9084],0); -ELEMENTS[61513] = Fluid3D([8467,8094,9084,9200],0); -ELEMENTS[61514] = Fluid3D([9582,10542,9559,9691],0); -ELEMENTS[61515] = Fluid3D([9559,9582,9691,9289],0); -ELEMENTS[61516] = Fluid3D([9691,9559,9289,10410],0); -ELEMENTS[61517] = Fluid3D([9289,9691,10410,10207],0); -ELEMENTS[61518] = Fluid3D([9289,9691,10207,9582],0); -ELEMENTS[61519] = Fluid3D([9691,10410,10207,10542],0); -ELEMENTS[61520] = Fluid3D([9691,10410,10542,9559],0); -ELEMENTS[61521] = Fluid3D([18073,18027,17861,17605],0); -ELEMENTS[61522] = Fluid3D([6187,6238,5784,6062],0); -ELEMENTS[61523] = Fluid3D([6187,6238,6062,6887],0); -ELEMENTS[61524] = Fluid3D([6062,6187,6887,6618],0); -ELEMENTS[61525] = Fluid3D([15711,15472,15895,15183],0); -ELEMENTS[61526] = Fluid3D([6693,6823,7470,7146],0); -ELEMENTS[61527] = Fluid3D([7912,8636,8729,8720],0); -ELEMENTS[61528] = Fluid3D([17522,17584,17864,17705],0); -ELEMENTS[61529] = Fluid3D([11273,10945,10794,9795],0); -ELEMENTS[61530] = Fluid3D([8541,9486,9002,9795],0); -ELEMENTS[61531] = Fluid3D([17598,17292,17707,17691],0); -ELEMENTS[61532] = Fluid3D([14928,14442,14792,14166],0); -ELEMENTS[61533] = Fluid3D([6541,7078,6050,6000],0); -ELEMENTS[61534] = Fluid3D([7998,8631,8861,8596],0); -ELEMENTS[61535] = Fluid3D([8871,8498,8399,9400],0); -ELEMENTS[61536] = Fluid3D([8871,8498,9400,9378],0); -ELEMENTS[61537] = Fluid3D([15982,16300,15940,15480],0); -ELEMENTS[61538] = Fluid3D([4263,4640,4166,4758],0); -ELEMENTS[61539] = Fluid3D([17665,17413,17436,17135],0); -ELEMENTS[61540] = Fluid3D([11706,10956,12069,10958],0); -ELEMENTS[61541] = Fluid3D([14386,14646,14884,14020],0); -ELEMENTS[61542] = Fluid3D([3060,3365,3206,3506],0); -ELEMENTS[61543] = Fluid3D([1660,1593,1681,1697],0); -ELEMENTS[61544] = Fluid3D([1681,1660,1697,1828],0); -ELEMENTS[61545] = Fluid3D([1697,1681,1828,1783],0); -ELEMENTS[61546] = Fluid3D([1828,1697,1783,1680],0); -ELEMENTS[61547] = Fluid3D([1828,1697,1680,1659],0); -ELEMENTS[61548] = Fluid3D([1697,1680,1659,1593],0); -ELEMENTS[61549] = Fluid3D([1659,1697,1593,1660],0); -ELEMENTS[61550] = Fluid3D([1697,1680,1593,1681],0); -ELEMENTS[61551] = Fluid3D([1828,1697,1659,1752],0); -ELEMENTS[61552] = Fluid3D([1697,1783,1680,1681],0); -ELEMENTS[61553] = Fluid3D([1659,1697,1660,1752],0); -ELEMENTS[61554] = Fluid3D([1660,1697,1828,1752],0); -ELEMENTS[61555] = Fluid3D([7592,7506,6827,7302],0); -ELEMENTS[61556] = Fluid3D([16028,16387,16296,15555],0); -ELEMENTS[61557] = Fluid3D([3832,3778,4272,3897],0); -ELEMENTS[61558] = Fluid3D([3832,3778,3897,3384],0); -ELEMENTS[61559] = Fluid3D([13174,12806,12929,12058],0); -ELEMENTS[61560] = Fluid3D([5122,5444,4885,5412],0); -ELEMENTS[61561] = Fluid3D([4885,5122,5412,5065],0); -ELEMENTS[61562] = Fluid3D([5412,4885,5065,5607],0); -ELEMENTS[61563] = Fluid3D([5065,5412,5607,5486],0); -ELEMENTS[61564] = Fluid3D([5122,5444,5412,5811],0); -ELEMENTS[61565] = Fluid3D([5444,5412,5811,5607],0); -ELEMENTS[61566] = Fluid3D([5444,5412,5607,4885],0); -ELEMENTS[61567] = Fluid3D([5412,5122,5811,5135],0); -ELEMENTS[61568] = Fluid3D([5412,5122,5135,5065],0); -ELEMENTS[61569] = Fluid3D([5412,5811,5607,5780],0); -ELEMENTS[61570] = Fluid3D([5412,5811,5780,5473],0); -ELEMENTS[61571] = Fluid3D([5780,5412,5473,5486],0); -ELEMENTS[61572] = Fluid3D([5412,5811,5473,5135],0); -ELEMENTS[61573] = Fluid3D([5473,5780,5486,5924],0); -ELEMENTS[61574] = Fluid3D([5811,5780,5473,6320],0); -ELEMENTS[61575] = Fluid3D([5780,5473,6320,5924],0); -ELEMENTS[61576] = Fluid3D([5607,5412,5780,5486],0); -ELEMENTS[61577] = Fluid3D([5811,5780,6320,6126],0); -ELEMENTS[61578] = Fluid3D([5780,6320,6126,6248],0); -ELEMENTS[61579] = Fluid3D([5473,5412,5135,5065],0); -ELEMENTS[61580] = Fluid3D([5473,5412,5065,5486],0); -ELEMENTS[61581] = Fluid3D([18291,18365,18433,18169],0); -ELEMENTS[61582] = Fluid3D([12968,13290,13486,12200],0); -ELEMENTS[61583] = Fluid3D([15777,16163,16026,15390],0); -ELEMENTS[61584] = Fluid3D([18136,18266,18312,18015],0); -ELEMENTS[61585] = Fluid3D([16329,16399,15628,15758],0); -ELEMENTS[61586] = Fluid3D([7997,8675,7519,7856],0); -ELEMENTS[61587] = Fluid3D([18680,18645,18661,18625],0); -ELEMENTS[61588] = Fluid3D([2476,2699,2454,2844],0); -ELEMENTS[61589] = Fluid3D([18059,18071,18227,17770],0); -ELEMENTS[61590] = Fluid3D([15546,14852,15151,14874],0); -ELEMENTS[61591] = Fluid3D([16220,15820,16062,15468],0); -ELEMENTS[61592] = Fluid3D([16688,16483,16847,16242],0); -ELEMENTS[61593] = Fluid3D([5984,5322,5426,5676],0); -ELEMENTS[61594] = Fluid3D([3330,2914,3149,3246],0); -ELEMENTS[61595] = Fluid3D([10975,10823,11600,12095],0); -ELEMENTS[61596] = Fluid3D([16721,16503,16169,16158],0); -ELEMENTS[61597] = Fluid3D([5981,6285,6721,6566],0); -ELEMENTS[61598] = Fluid3D([5190,5457,4892,5469],0); -ELEMENTS[61599] = Fluid3D([8876,8046,8989,9281],0); -ELEMENTS[61600] = Fluid3D([8989,8876,9281,9851],0); -ELEMENTS[61601] = Fluid3D([9281,8989,9851,9967],0); -ELEMENTS[61602] = Fluid3D([9281,8989,9967,9105],0); -ELEMENTS[61603] = Fluid3D([9281,8989,9105,8520],0); -ELEMENTS[61604] = Fluid3D([9281,8989,8520,8046],0); -ELEMENTS[61605] = Fluid3D([9851,9281,9967,10561],0); -ELEMENTS[61606] = Fluid3D([9967,9281,9105,10121],0); -ELEMENTS[61607] = Fluid3D([13242,13073,12727,11921],0); -ELEMENTS[61608] = Fluid3D([12418,12525,13016,12587],0); -ELEMENTS[61609] = Fluid3D([12525,13016,12587,11900],0); -ELEMENTS[61610] = Fluid3D([12525,13016,11900,12702],0); -ELEMENTS[61611] = Fluid3D([13087,13774,12925,12924],0); -ELEMENTS[61612] = Fluid3D([12363,11418,11670,12368],0); -ELEMENTS[61613] = Fluid3D([7314,8156,7616,8125],0); -ELEMENTS[61614] = Fluid3D([18457,18408,18523,18354],0); -ELEMENTS[61615] = Fluid3D([14074,13601,13979,12963],0); -ELEMENTS[61616] = Fluid3D([8627,9637,9427,9247],0); -ELEMENTS[61617] = Fluid3D([1862,1969,2022,2146],0); -ELEMENTS[61618] = Fluid3D([18542,18401,18453,18518],0); -ELEMENTS[61619] = Fluid3D([18225,18167,18033,17975],0); -ELEMENTS[61620] = Fluid3D([18033,18225,17975,18105],0); -ELEMENTS[61621] = Fluid3D([18225,17975,18105,18035],0); -ELEMENTS[61622] = Fluid3D([2969,3094,3312,3362],0); -ELEMENTS[61623] = Fluid3D([2973,3383,3321,3204],0); -ELEMENTS[61624] = Fluid3D([17276,17112,16829,16784],0); -ELEMENTS[61625] = Fluid3D([2974,3384,3011,3115],0); -ELEMENTS[61626] = Fluid3D([3384,3011,3115,3502],0); -ELEMENTS[61627] = Fluid3D([3115,3384,3502,3491],0); -ELEMENTS[61628] = Fluid3D([3384,3502,3491,3897],0); -ELEMENTS[61629] = Fluid3D([3115,3384,3491,2974],0); -ELEMENTS[61630] = Fluid3D([3011,2974,3115,2931],0); -ELEMENTS[61631] = Fluid3D([2974,3115,2931,3491],0); -ELEMENTS[61632] = Fluid3D([3115,2931,3491,3458],0); -ELEMENTS[61633] = Fluid3D([3502,3491,3897,3458],0); -ELEMENTS[61634] = Fluid3D([3115,3011,2931,3065],0); -ELEMENTS[61635] = Fluid3D([2931,3115,3065,3458],0); -ELEMENTS[61636] = Fluid3D([3502,3115,3491,3458],0); -ELEMENTS[61637] = Fluid3D([3688,4206,3829,3807],0); -ELEMENTS[61638] = Fluid3D([5823,6223,5594,6040],0); -ELEMENTS[61639] = Fluid3D([16296,15912,16028,15376],0); -ELEMENTS[61640] = Fluid3D([5121,4641,4538,4990],0); -ELEMENTS[61641] = Fluid3D([4538,5121,4990,5096],0); -ELEMENTS[61642] = Fluid3D([5121,4990,5096,5737],0); -ELEMENTS[61643] = Fluid3D([8169,8817,7955,8996],0); -ELEMENTS[61644] = Fluid3D([6078,5649,5467,5882],0); -ELEMENTS[61645] = Fluid3D([5467,6078,5882,6102],0); -ELEMENTS[61646] = Fluid3D([5649,5467,5882,5070],0); -ELEMENTS[61647] = Fluid3D([17712,17674,17949,18102],0); -ELEMENTS[61648] = Fluid3D([3090,3459,3235,3658],0); -ELEMENTS[61649] = Fluid3D([9220,9365,8605,8204],0); -ELEMENTS[61650] = Fluid3D([13820,14331,13398,13786],0); -ELEMENTS[61651] = Fluid3D([13398,13820,13786,12825],0); -ELEMENTS[61652] = Fluid3D([13820,14331,13786,14732],0); -ELEMENTS[61653] = Fluid3D([13820,13786,12825,13278],0); -ELEMENTS[61654] = Fluid3D([13786,13820,14732,14307],0); -ELEMENTS[61655] = Fluid3D([13820,13786,13278,14307],0); -ELEMENTS[61656] = Fluid3D([11861,11233,10637,11635],0); -ELEMENTS[61657] = Fluid3D([11861,11233,11635,11852],0); -ELEMENTS[61658] = Fluid3D([11233,11635,11852,10976],0); -ELEMENTS[61659] = Fluid3D([11635,11852,10976,12179],0); -ELEMENTS[61660] = Fluid3D([11233,10637,11635,10976],0); -ELEMENTS[61661] = Fluid3D([4835,5307,5356,5605],0); -ELEMENTS[61662] = Fluid3D([16480,16737,16824,16257],0); -ELEMENTS[61663] = Fluid3D([17039,16662,17110,16849],0); -ELEMENTS[61664] = Fluid3D([2784,3044,2895,2674],0); -ELEMENTS[61665] = Fluid3D([16359,16716,16553,16124],0); -ELEMENTS[61666] = Fluid3D([9944,10156,10874,9961],0); -ELEMENTS[61667] = Fluid3D([14992,14983,15607,15575],0); -ELEMENTS[61668] = Fluid3D([3002,2692,2878,3164],0); -ELEMENTS[61669] = Fluid3D([7410,7158,8089,7360],0); -ELEMENTS[61670] = Fluid3D([7410,7158,7360,6746],0); -ELEMENTS[61671] = Fluid3D([7360,7410,6746,6908],0); -ELEMENTS[61672] = Fluid3D([7158,7360,6746,6987],0); -ELEMENTS[61673] = Fluid3D([8089,7410,7360,7849],0); -ELEMENTS[61674] = Fluid3D([7410,7360,7849,6908],0); -ELEMENTS[61675] = Fluid3D([6746,7360,6908,7015],0); -ELEMENTS[61676] = Fluid3D([6908,6746,7015,6296],0); -ELEMENTS[61677] = Fluid3D([7158,7360,6987,8042],0); -ELEMENTS[61678] = Fluid3D([7158,8089,7360,8042],0); -ELEMENTS[61679] = Fluid3D([15004,15133,15662,14786],0); -ELEMENTS[61680] = Fluid3D([4472,4317,3993,4434],0); -ELEMENTS[61681] = Fluid3D([17538,17797,17654,17457],0); -ELEMENTS[61682] = Fluid3D([2794,2817,3118,3223],0); -ELEMENTS[61683] = Fluid3D([14433,13763,14637,13957],0); -ELEMENTS[61684] = Fluid3D([4913,4508,4858,4330],0); -ELEMENTS[61685] = Fluid3D([4155,3713,3884,4059],0); -ELEMENTS[61686] = Fluid3D([3713,3884,4059,3468],0); -ELEMENTS[61687] = Fluid3D([3884,4155,4059,4477],0); -ELEMENTS[61688] = Fluid3D([4059,3884,4477,3932],0); -ELEMENTS[61689] = Fluid3D([4059,3884,3932,3678],0); -ELEMENTS[61690] = Fluid3D([3884,4059,3468,3678],0); -ELEMENTS[61691] = Fluid3D([3932,4059,3678,4036],0); -ELEMENTS[61692] = Fluid3D([15799,15972,16181,15389],0); -ELEMENTS[61693] = Fluid3D([16952,17272,16851,16686],0); -ELEMENTS[61694] = Fluid3D([3895,3428,3832,3906],0); -ELEMENTS[61695] = Fluid3D([3832,3895,3906,4335],0); -ELEMENTS[61696] = Fluid3D([3895,3906,4335,4372],0); -ELEMENTS[61697] = Fluid3D([18538,18597,18519,18421],0); -ELEMENTS[61698] = Fluid3D([12243,11268,11634,12250],0); -ELEMENTS[61699] = Fluid3D([11213,12172,11910,11658],0); -ELEMENTS[61700] = Fluid3D([18570,18523,18483,18393],0); -ELEMENTS[61701] = Fluid3D([2320,2509,2558,2568],0); -ELEMENTS[61702] = Fluid3D([6369,5749,5891,5975],0); -ELEMENTS[61703] = Fluid3D([9133,9872,10038,10572],0); -ELEMENTS[61704] = Fluid3D([9872,10038,10572,10822],0); -ELEMENTS[61705] = Fluid3D([10572,9872,10822,10795],0); -ELEMENTS[61706] = Fluid3D([17062,16939,17238,16777],0); -ELEMENTS[61707] = Fluid3D([17238,17062,16777,16965],0); -ELEMENTS[61708] = Fluid3D([17062,16939,16777,16453],0); -ELEMENTS[61709] = Fluid3D([16939,17238,16777,17111],0); -ELEMENTS[61710] = Fluid3D([13099,13618,13417,12575],0); -ELEMENTS[61711] = Fluid3D([5895,5338,5380,5959],0); -ELEMENTS[61712] = Fluid3D([15812,15656,15282,15447],0); -ELEMENTS[61713] = Fluid3D([8158,8709,7811,9054],0); -ELEMENTS[61714] = Fluid3D([15084,14823,15283,14513],0); -ELEMENTS[61715] = Fluid3D([5288,5437,4944,4950],0); -ELEMENTS[61716] = Fluid3D([3826,3885,4326,3982],0); -ELEMENTS[61717] = Fluid3D([12716,13202,12832,12242],0); -ELEMENTS[61718] = Fluid3D([12716,13202,12242,11785],0); -ELEMENTS[61719] = Fluid3D([12242,12716,11785,11784],0); -ELEMENTS[61720] = Fluid3D([11785,12242,11784,11941],0); -ELEMENTS[61721] = Fluid3D([12242,11784,11941,12716],0); -ELEMENTS[61722] = Fluid3D([11785,12242,11941,12324],0); -ELEMENTS[61723] = Fluid3D([12242,11941,12324,12832],0); -ELEMENTS[61724] = Fluid3D([11785,12242,12324,13202],0); -ELEMENTS[61725] = Fluid3D([12242,11941,12832,12716],0); -ELEMENTS[61726] = Fluid3D([12242,12324,13202,12832],0); -ELEMENTS[61727] = Fluid3D([8627,9427,8447,8837],0); -ELEMENTS[61728] = Fluid3D([9427,8447,8837,8735],0); -ELEMENTS[61729] = Fluid3D([8447,8627,8837,8305],0); -ELEMENTS[61730] = Fluid3D([8627,9427,8837,9247],0); -ELEMENTS[61731] = Fluid3D([8837,8627,9247,8305],0); -ELEMENTS[61732] = Fluid3D([9247,8837,8305,9213],0); -ELEMENTS[61733] = Fluid3D([9247,8837,9213,9556],0); -ELEMENTS[61734] = Fluid3D([8731,9327,8325,9448],0); -ELEMENTS[61735] = Fluid3D([18566,18635,18633,18575],0); -ELEMENTS[61736] = Fluid3D([14522,14838,14346,13615],0); -ELEMENTS[61737] = Fluid3D([16131,15639,16123,15701],0); -ELEMENTS[61738] = Fluid3D([16239,16529,16775,16304],0); -ELEMENTS[61739] = Fluid3D([14037,14522,14346,13615],0); -ELEMENTS[61740] = Fluid3D([17390,17245,16962,16885],0); -ELEMENTS[61741] = Fluid3D([7923,7938,7130,7823],0); -ELEMENTS[61742] = Fluid3D([3482,3986,3609,3844],0); -ELEMENTS[61743] = Fluid3D([1876,2028,1917,2126],0); -ELEMENTS[61744] = Fluid3D([13685,13755,12976,13746],0); -ELEMENTS[61745] = Fluid3D([5445,5598,6054,5218],0); -ELEMENTS[61746] = Fluid3D([5433,5948,5380,5522],0); -ELEMENTS[61747] = Fluid3D([4274,4022,3815,4222],0); -ELEMENTS[61748] = Fluid3D([16448,16851,16343,16259],0); -ELEMENTS[61749] = Fluid3D([4954,4349,4780,4682],0); -ELEMENTS[61750] = Fluid3D([10051,9913,8925,9589],0); -ELEMENTS[61751] = Fluid3D([9913,8925,9589,8916],0); -ELEMENTS[61752] = Fluid3D([5953,5582,6362,6174],0); -ELEMENTS[61753] = Fluid3D([15283,14823,15032,14027],0); -ELEMENTS[61754] = Fluid3D([3755,3358,3632,3828],0); -ELEMENTS[61755] = Fluid3D([6823,7607,7470,7594],0); -ELEMENTS[61756] = Fluid3D([17055,17000,17287,16718],0); -ELEMENTS[61757] = Fluid3D([16343,16244,15779,15886],0); -ELEMENTS[61758] = Fluid3D([15779,16343,15886,15896],0); -ELEMENTS[61759] = Fluid3D([16244,15779,15886,15345],0); -ELEMENTS[61760] = Fluid3D([15779,15886,15345,15381],0); -ELEMENTS[61761] = Fluid3D([15886,15345,15381,15887],0); -ELEMENTS[61762] = Fluid3D([15886,15345,15887,15774],0); -ELEMENTS[61763] = Fluid3D([15345,15887,15774,15730],0); -ELEMENTS[61764] = Fluid3D([15887,15774,15730,16206],0); -ELEMENTS[61765] = Fluid3D([15730,15887,16206,16259],0); -ELEMENTS[61766] = Fluid3D([15730,15887,16259,15381],0); -ELEMENTS[61767] = Fluid3D([15730,15887,15381,15345],0); -ELEMENTS[61768] = Fluid3D([15887,16206,16259,15774],0); -ELEMENTS[61769] = Fluid3D([16259,15887,15774,15886],0); -ELEMENTS[61770] = Fluid3D([16259,15887,15886,15381],0); -ELEMENTS[61771] = Fluid3D([15886,15779,15896,15381],0); -ELEMENTS[61772] = Fluid3D([10441,9441,9870,10072],0); -ELEMENTS[61773] = Fluid3D([9441,9870,10072,8923],0); -ELEMENTS[61774] = Fluid3D([8268,7417,7922,8208],0); -ELEMENTS[61775] = Fluid3D([7417,7922,8208,7077],0); -ELEMENTS[61776] = Fluid3D([7922,8268,8208,8818],0); -ELEMENTS[61777] = Fluid3D([18647,18595,18630,18565],0); -ELEMENTS[61778] = Fluid3D([13191,13105,12710,12024],0); -ELEMENTS[61779] = Fluid3D([5162,5072,4640,5116],0); -ELEMENTS[61780] = Fluid3D([4640,5162,5116,4751],0); -ELEMENTS[61781] = Fluid3D([5162,5116,4751,5294],0); -ELEMENTS[61782] = Fluid3D([5116,4640,4751,4991],0); -ELEMENTS[61783] = Fluid3D([5116,4751,5294,5144],0); -ELEMENTS[61784] = Fluid3D([5162,5116,5294,5616],0); -ELEMENTS[61785] = Fluid3D([5162,5116,5616,5776],0); -ELEMENTS[61786] = Fluid3D([5116,5616,5776,4991],0); -ELEMENTS[61787] = Fluid3D([14073,13280,13367,13023],0); -ELEMENTS[61788] = Fluid3D([18242,18352,18394,18165],0); -ELEMENTS[61789] = Fluid3D([11377,12408,11607,12389],0); -ELEMENTS[61790] = Fluid3D([11377,12408,12389,11782],0); -ELEMENTS[61791] = Fluid3D([12408,11607,12389,12427],0); -ELEMENTS[61792] = Fluid3D([16310,16439,16062,15889],0); -ELEMENTS[61793] = Fluid3D([16310,16439,15889,15718],0); -ELEMENTS[61794] = Fluid3D([16439,16062,15889,16220],0); -ELEMENTS[61795] = Fluid3D([16062,16310,15889,15445],0); -ELEMENTS[61796] = Fluid3D([15889,16310,15718,15445],0); -ELEMENTS[61797] = Fluid3D([15718,15889,15445,15468],0); -ELEMENTS[61798] = Fluid3D([15889,15445,15468,16062],0); -ELEMENTS[61799] = Fluid3D([15718,15889,15468,15965],0); -ELEMENTS[61800] = Fluid3D([15718,15889,15965,16439],0); -ELEMENTS[61801] = Fluid3D([15468,15889,16062,16220],0); -ELEMENTS[61802] = Fluid3D([15445,15718,15468,15252],0); -ELEMENTS[61803] = Fluid3D([15445,15718,15252,14801],0); -ELEMENTS[61804] = Fluid3D([15445,15718,14801,15574],0); -ELEMENTS[61805] = Fluid3D([15445,15718,15574,16050],0); -ELEMENTS[61806] = Fluid3D([15445,15718,16050,16310],0); -ELEMENTS[61807] = Fluid3D([16990,17153,17299,16862],0); -ELEMENTS[61808] = Fluid3D([16990,17153,16862,16457],0); -ELEMENTS[61809] = Fluid3D([17153,17299,16862,17182],0); -ELEMENTS[61810] = Fluid3D([17299,16990,16862,16693],0); -ELEMENTS[61811] = Fluid3D([16990,16862,16693,16457],0); -ELEMENTS[61812] = Fluid3D([16862,17153,17182,16446],0); -ELEMENTS[61813] = Fluid3D([7523,8447,8288,8043],0); -ELEMENTS[61814] = Fluid3D([2941,3130,3286,3386],0); -ELEMENTS[61815] = Fluid3D([8298,7787,7722,8551],0); -ELEMENTS[61816] = Fluid3D([2175,2391,2296,2490],0); -ELEMENTS[61817] = Fluid3D([14337,14950,14278,14555],0); -ELEMENTS[61818] = Fluid3D([5712,5444,5122,5811],0); -ELEMENTS[61819] = Fluid3D([11424,10652,10029,9961],0); -ELEMENTS[61820] = Fluid3D([10652,10029,9961,9583],0); -ELEMENTS[61821] = Fluid3D([1659,1575,1639,1727],0); -ELEMENTS[61822] = Fluid3D([12138,12663,12362,12281],0); -ELEMENTS[61823] = Fluid3D([11714,10779,11799,11203],0); -ELEMENTS[61824] = Fluid3D([14932,15111,15544,15337],0); -ELEMENTS[61825] = Fluid3D([6391,5918,5767,6102],0); -ELEMENTS[61826] = Fluid3D([16169,15546,15819,15800],0); -ELEMENTS[61827] = Fluid3D([2738,2476,2511,2667],0); -ELEMENTS[61828] = Fluid3D([2476,2511,2667,2542],0); -ELEMENTS[61829] = Fluid3D([15029,14551,14813,14329],0); -ELEMENTS[61830] = Fluid3D([2052,1889,1987,2118],0); -ELEMENTS[61831] = Fluid3D([15583,15820,15995,15191],0); -ELEMENTS[61832] = Fluid3D([5951,6634,6667,6192],0); -ELEMENTS[61833] = Fluid3D([8403,8179,7561,7428],0); -ELEMENTS[61834] = Fluid3D([7150,6996,6752,6383],0); -ELEMENTS[61835] = Fluid3D([6752,7150,6383,6537],0); -ELEMENTS[61836] = Fluid3D([7150,6383,6537,6708],0); -ELEMENTS[61837] = Fluid3D([6537,7150,6708,7357],0); -ELEMENTS[61838] = Fluid3D([6708,6537,7357,6829],0); -ELEMENTS[61839] = Fluid3D([6383,6537,6708,6123],0); -ELEMENTS[61840] = Fluid3D([6383,6537,6123,6752],0); -ELEMENTS[61841] = Fluid3D([6123,6383,6752,6135],0); -ELEMENTS[61842] = Fluid3D([6123,6383,6135,6244],0); -ELEMENTS[61843] = Fluid3D([6537,6708,6123,5773],0); -ELEMENTS[61844] = Fluid3D([7357,6708,6829,6608],0); -ELEMENTS[61845] = Fluid3D([6708,6383,6123,6450],0); -ELEMENTS[61846] = Fluid3D([6383,6123,6450,6244],0); -ELEMENTS[61847] = Fluid3D([6450,6383,6244,6996],0); -ELEMENTS[61848] = Fluid3D([6708,6383,6450,7150],0); -ELEMENTS[61849] = Fluid3D([6383,6450,7150,6996],0); -ELEMENTS[61850] = Fluid3D([6708,6537,6829,6073],0); -ELEMENTS[61851] = Fluid3D([6996,6752,6383,6135],0); -ELEMENTS[61852] = Fluid3D([5371,5660,5981,5844],0); -ELEMENTS[61853] = Fluid3D([3476,3219,3104,3570],0); -ELEMENTS[61854] = Fluid3D([9593,10012,9047,9983],0); -ELEMENTS[61855] = Fluid3D([7861,8753,8156,8920],0); -ELEMENTS[61856] = Fluid3D([14088,13335,14256,14488],0); -ELEMENTS[61857] = Fluid3D([10988,11939,11191,11495],0); -ELEMENTS[61858] = Fluid3D([9876,9708,10818,10057],0); -ELEMENTS[61859] = Fluid3D([13743,12955,12899,13609],0); -ELEMENTS[61860] = Fluid3D([4502,4069,4231,4755],0); -ELEMENTS[61861] = Fluid3D([16292,16249,16577,15963],0); -ELEMENTS[61862] = Fluid3D([16300,16632,16588,16194],0); -ELEMENTS[61863] = Fluid3D([13955,13287,13190,14361],0); -ELEMENTS[61864] = Fluid3D([6223,6714,5989,6449],0); -ELEMENTS[61865] = Fluid3D([5905,6592,6162,6942],0); -ELEMENTS[61866] = Fluid3D([14637,15236,14433,14856],0); -ELEMENTS[61867] = Fluid3D([13979,14376,14449,13352],0); -ELEMENTS[61868] = Fluid3D([5808,5266,5993,5118],0); -ELEMENTS[61869] = Fluid3D([5808,5266,5118,4998],0); -ELEMENTS[61870] = Fluid3D([5266,5118,4998,4595],0); -ELEMENTS[61871] = Fluid3D([5266,5118,4595,4850],0); -ELEMENTS[61872] = Fluid3D([8880,8977,9389,9846],0); -ELEMENTS[61873] = Fluid3D([6503,6059,5840,6639],0); -ELEMENTS[61874] = Fluid3D([16850,16539,16177,16684],0); -ELEMENTS[61875] = Fluid3D([16850,16539,16684,16766],0); -ELEMENTS[61876] = Fluid3D([16177,16850,16684,16484],0); -ELEMENTS[61877] = Fluid3D([16850,16684,16484,17142],0); -ELEMENTS[61878] = Fluid3D([13166,12150,12492,13125],0); -ELEMENTS[61879] = Fluid3D([17918,17954,18115,17935],0); -ELEMENTS[61880] = Fluid3D([11917,10924,11238,11009],0); -ELEMENTS[61881] = Fluid3D([14399,14197,14690,13813],0); -ELEMENTS[61882] = Fluid3D([14641,15131,15622,15403],0); -ELEMENTS[61883] = Fluid3D([6693,7346,6584,7146],0); -ELEMENTS[61884] = Fluid3D([5424,4903,5356,5775],0); -ELEMENTS[61885] = Fluid3D([17690,17466,17427,17176],0); -ELEMENTS[61886] = Fluid3D([16160,16033,16420,16762],0); -ELEMENTS[61887] = Fluid3D([13597,13490,14274,14120],0); -ELEMENTS[61888] = Fluid3D([14274,13597,14120,13748],0); -ELEMENTS[61889] = Fluid3D([14120,14274,13748,14743],0); -ELEMENTS[61890] = Fluid3D([14274,13597,13748,14234],0); -ELEMENTS[61891] = Fluid3D([18186,17923,17988,17957],0); -ELEMENTS[61892] = Fluid3D([18186,17923,17957,18012],0); -ELEMENTS[61893] = Fluid3D([17988,18186,17957,17877],0); -ELEMENTS[61894] = Fluid3D([17957,17988,17877,17727],0); -ELEMENTS[61895] = Fluid3D([17877,17957,17727,18012],0); -ELEMENTS[61896] = Fluid3D([17877,17957,18012,18278],0); -ELEMENTS[61897] = Fluid3D([17957,17727,18012,17923],0); -ELEMENTS[61898] = Fluid3D([17957,17727,17923,17988],0); -ELEMENTS[61899] = Fluid3D([17957,18186,18012,18278],0); -ELEMENTS[61900] = Fluid3D([18186,17957,17877,18278],0); -ELEMENTS[61901] = Fluid3D([15240,15726,15268,15849],0); -ELEMENTS[61902] = Fluid3D([15359,15568,15072,15541],0); -ELEMENTS[61903] = Fluid3D([15568,15072,15541,15421],0); -ELEMENTS[61904] = Fluid3D([15541,15568,15421,15977],0); -ELEMENTS[61905] = Fluid3D([15568,15421,15977,15715],0); -ELEMENTS[61906] = Fluid3D([15568,15421,15715,15110],0); -ELEMENTS[61907] = Fluid3D([15568,15421,15110,15072],0); -ELEMENTS[61908] = Fluid3D([15541,15568,15977,16024],0); -ELEMENTS[61909] = Fluid3D([15421,15541,15977,15545],0); -ELEMENTS[61910] = Fluid3D([15977,15421,15545,15313],0); -ELEMENTS[61911] = Fluid3D([15568,15977,16024,16327],0); -ELEMENTS[61912] = Fluid3D([16879,16716,16526,16145],0); -ELEMENTS[61913] = Fluid3D([7298,7886,7583,8509],0); -ELEMENTS[61914] = Fluid3D([13439,13580,13923,12950],0); -ELEMENTS[61915] = Fluid3D([5896,6244,5546,5232],0); -ELEMENTS[61916] = Fluid3D([7057,7672,7820,7056],0); -ELEMENTS[61917] = Fluid3D([17887,18086,17720,18063],0); -ELEMENTS[61918] = Fluid3D([13314,13466,12964,12664],0); -ELEMENTS[61919] = Fluid3D([11837,11985,11054,11273],0); -ELEMENTS[61920] = Fluid3D([10836,10947,11740,10653],0); -ELEMENTS[61921] = Fluid3D([4023,3623,3962,4205],0); -ELEMENTS[61922] = Fluid3D([2660,2709,2396,2439],0); -ELEMENTS[61923] = Fluid3D([9829,10827,10517,9884],0); -ELEMENTS[61924] = Fluid3D([14605,14295,14121,13866],0); -ELEMENTS[61925] = Fluid3D([15190,15608,15460,14840],0); -ELEMENTS[61926] = Fluid3D([6329,6794,7308,6792],0); -ELEMENTS[61927] = Fluid3D([5474,5552,5297,4784],0); -ELEMENTS[61928] = Fluid3D([14251,14535,14029,14610],0); -ELEMENTS[61929] = Fluid3D([8835,9599,9720,9836],0); -ELEMENTS[61930] = Fluid3D([8835,9599,9836,8729],0); -ELEMENTS[61931] = Fluid3D([9599,9720,9836,10661],0); -ELEMENTS[61932] = Fluid3D([9599,9836,8729,9612],0); -ELEMENTS[61933] = Fluid3D([9599,9836,9612,10533],0); -ELEMENTS[61934] = Fluid3D([9599,9836,10533,10535],0); -ELEMENTS[61935] = Fluid3D([12265,11753,12094,11294],0); -ELEMENTS[61936] = Fluid3D([18668,18641,18676,18647],0); -ELEMENTS[61937] = Fluid3D([6444,6414,5846,6886],0); -ELEMENTS[61938] = Fluid3D([7677,7787,6854,6836],0); -ELEMENTS[61939] = Fluid3D([6680,6121,6015,6331],0); -ELEMENTS[61940] = Fluid3D([13198,12388,12311,12924],0); -ELEMENTS[61941] = Fluid3D([12311,13198,12924,12925],0); -ELEMENTS[61942] = Fluid3D([13198,12388,12924,12723],0); -ELEMENTS[61943] = Fluid3D([6281,5956,5655,6109],0); -ELEMENTS[61944] = Fluid3D([4664,4916,5232,5127],0); -ELEMENTS[61945] = Fluid3D([4664,4916,5127,4950],0); -ELEMENTS[61946] = Fluid3D([5232,4664,5127,5055],0); -ELEMENTS[61947] = Fluid3D([4664,5127,5055,5288],0); -ELEMENTS[61948] = Fluid3D([5127,5055,5288,5232],0); -ELEMENTS[61949] = Fluid3D([4916,5232,5127,5554],0); -ELEMENTS[61950] = Fluid3D([5127,4916,5554,5546],0); -ELEMENTS[61951] = Fluid3D([5554,5127,5546,5232],0); -ELEMENTS[61952] = Fluid3D([4916,5232,5554,5539],0); -ELEMENTS[61953] = Fluid3D([5232,5554,5539,5912],0); -ELEMENTS[61954] = Fluid3D([5554,5539,5912,6244],0); -ELEMENTS[61955] = Fluid3D([5554,4916,5539,5153],0); -ELEMENTS[61956] = Fluid3D([5539,5232,5912,6135],0); -ELEMENTS[61957] = Fluid3D([5539,5554,5153,5881],0); -ELEMENTS[61958] = Fluid3D([5539,5554,5881,6244],0); -ELEMENTS[61959] = Fluid3D([5554,5881,6244,5546],0); -ELEMENTS[61960] = Fluid3D([5127,4916,5546,4950],0); -ELEMENTS[61961] = Fluid3D([5546,5127,4950,5288],0); -ELEMENTS[61962] = Fluid3D([5546,5127,5288,5232],0); -ELEMENTS[61963] = Fluid3D([5055,4664,5288,4454],0); -ELEMENTS[61964] = Fluid3D([5554,5153,5881,5043],0); -ELEMENTS[61965] = Fluid3D([5554,5881,5546,5043],0); -ELEMENTS[61966] = Fluid3D([11961,11600,12095,10975],0); -ELEMENTS[61967] = Fluid3D([10871,11845,11502,10838],0); -ELEMENTS[61968] = Fluid3D([5651,6315,6260,5671],0); -ELEMENTS[61969] = Fluid3D([4392,4511,5052,4569],0); -ELEMENTS[61970] = Fluid3D([17238,17538,17371,16965],0); -ELEMENTS[61971] = Fluid3D([8282,7717,8048,7489],0); -ELEMENTS[61972] = Fluid3D([15584,15376,14936,15623],0); -ELEMENTS[61973] = Fluid3D([2344,2264,2504,2578],0); -ELEMENTS[61974] = Fluid3D([15513,14923,15636,15344],0); -ELEMENTS[61975] = Fluid3D([12081,12548,12143,11515],0); -ELEMENTS[61976] = Fluid3D([12081,12548,11515,12487],0); -ELEMENTS[61977] = Fluid3D([12548,12143,11515,11993],0); -ELEMENTS[61978] = Fluid3D([11515,12548,11993,12098],0); -ELEMENTS[61979] = Fluid3D([11993,11515,12098,11763],0); -ELEMENTS[61980] = Fluid3D([11515,12548,12098,12022],0); -ELEMENTS[61981] = Fluid3D([12548,11993,12098,12983],0); -ELEMENTS[61982] = Fluid3D([12098,12548,12983,12022],0); -ELEMENTS[61983] = Fluid3D([12983,12098,12022,11763],0); -ELEMENTS[61984] = Fluid3D([12098,12022,11763,11515],0); -ELEMENTS[61985] = Fluid3D([12983,12098,11763,12680],0); -ELEMENTS[61986] = Fluid3D([12098,11993,11763,12680],0); -ELEMENTS[61987] = Fluid3D([12143,12081,11515,10925],0); -ELEMENTS[61988] = Fluid3D([11515,12143,10925,11152],0); -ELEMENTS[61989] = Fluid3D([14417,13505,13832,13629],0); -ELEMENTS[61990] = Fluid3D([18573,18542,18453,18518],0); -ELEMENTS[61991] = Fluid3D([14175,13801,14284,13321],0); -ELEMENTS[61992] = Fluid3D([16139,15931,15648,15360],0); -ELEMENTS[61993] = Fluid3D([8967,8146,8186,7977],0); -ELEMENTS[61994] = Fluid3D([15180,15365,15377,15967],0); -ELEMENTS[61995] = Fluid3D([8467,9084,9355,8881],0); -ELEMENTS[61996] = Fluid3D([8467,9084,8881,9200],0); -ELEMENTS[61997] = Fluid3D([16302,16083,15698,15654],0); -ELEMENTS[61998] = Fluid3D([18128,18309,17982,17802],0); -ELEMENTS[61999] = Fluid3D([11910,12842,12604,12208],0); -ELEMENTS[62000] = Fluid3D([5570,5166,5105,4975],0); -ELEMENTS[62001] = Fluid3D([5570,5166,4975,5622],0); -ELEMENTS[62002] = Fluid3D([5948,5895,5380,5959],0); -ELEMENTS[62003] = Fluid3D([4323,4466,4202,4883],0); -ELEMENTS[62004] = Fluid3D([17717,17915,17953,17572],0); -ELEMENTS[62005] = Fluid3D([17953,17717,17572,17766],0); -ELEMENTS[62006] = Fluid3D([18443,18306,18360,18117],0); -ELEMENTS[62007] = Fluid3D([2919,3234,3340,3062],0); -ELEMENTS[62008] = Fluid3D([12281,12663,12968,11495],0); -ELEMENTS[62009] = Fluid3D([10784,10961,11897,11509],0); -ELEMENTS[62010] = Fluid3D([16483,16293,16653,15880],0); -ELEMENTS[62011] = Fluid3D([4045,4198,3755,4493],0); -ELEMENTS[62012] = Fluid3D([7035,6260,7072,6909],0); -ELEMENTS[62013] = Fluid3D([7700,8390,7592,7679],0); -ELEMENTS[62014] = Fluid3D([17518,17233,17466,16931],0); -ELEMENTS[62015] = Fluid3D([17923,17584,17668,17727],0); -ELEMENTS[62016] = Fluid3D([4077,4524,4644,4479],0); -ELEMENTS[62017] = Fluid3D([18382,18284,18428,18127],0); -ELEMENTS[62018] = Fluid3D([6145,6385,6907,6019],0); -ELEMENTS[62019] = Fluid3D([16879,17200,17043,16687],0); -ELEMENTS[62020] = Fluid3D([11587,11039,10581,11849],0); -ELEMENTS[62021] = Fluid3D([2076,2201,2273,2480],0); -ELEMENTS[62022] = Fluid3D([9584,9316,10372,9274],0); -ELEMENTS[62023] = Fluid3D([18394,18352,18481,18299],0); -ELEMENTS[62024] = Fluid3D([18352,18481,18299,18311],0); -ELEMENTS[62025] = Fluid3D([18481,18299,18311,18370],0); -ELEMENTS[62026] = Fluid3D([18299,18311,18370,18165],0); -ELEMENTS[62027] = Fluid3D([18299,18311,18165,18352],0); -ELEMENTS[62028] = Fluid3D([18370,18299,18165,18396],0); -ELEMENTS[62029] = Fluid3D([18370,18299,18396,18394],0); -ELEMENTS[62030] = Fluid3D([18299,18165,18396,18394],0); -ELEMENTS[62031] = Fluid3D([18481,18299,18370,18394],0); -ELEMENTS[62032] = Fluid3D([18299,18165,18394,18352],0); -ELEMENTS[62033] = Fluid3D([18311,18481,18370,18344],0); -ELEMENTS[62034] = Fluid3D([18370,18311,18344,18048],0); -ELEMENTS[62035] = Fluid3D([18311,18344,18048,18352],0); -ELEMENTS[62036] = Fluid3D([18311,18370,18165,18048],0); -ELEMENTS[62037] = Fluid3D([18165,18311,18048,18352],0); -ELEMENTS[62038] = Fluid3D([18165,18370,18396,18307],0); -ELEMENTS[62039] = Fluid3D([18370,18396,18307,18452],0); -ELEMENTS[62040] = Fluid3D([18370,18396,18452,18568],0); -ELEMENTS[62041] = Fluid3D([18396,18307,18452,18517],0); -ELEMENTS[62042] = Fluid3D([18396,18307,18517,18394],0); -ELEMENTS[62043] = Fluid3D([18396,18165,18307,18394],0); -ELEMENTS[62044] = Fluid3D([18311,18481,18344,18352],0); -ELEMENTS[62045] = Fluid3D([18370,18396,18568,18517],0); -ELEMENTS[62046] = Fluid3D([18370,18396,18517,18394],0); -ELEMENTS[62047] = Fluid3D([18396,18568,18517,18452],0); -ELEMENTS[62048] = Fluid3D([5604,5430,5032,5916],0); -ELEMENTS[62049] = Fluid3D([1872,2027,1961,2122],0); -ELEMENTS[62050] = Fluid3D([6283,6977,6044,6587],0); -ELEMENTS[62051] = Fluid3D([6283,6977,6587,6447],0); -ELEMENTS[62052] = Fluid3D([6587,6283,6447,6087],0); -ELEMENTS[62053] = Fluid3D([6283,6447,6087,5476],0); -ELEMENTS[62054] = Fluid3D([17270,17400,17675,16968],0); -ELEMENTS[62055] = Fluid3D([3912,4376,4263,4507],0); -ELEMENTS[62056] = Fluid3D([12563,11693,11818,12656],0); -ELEMENTS[62057] = Fluid3D([4122,3936,4417,4294],0); -ELEMENTS[62058] = Fluid3D([3936,4417,4294,4216],0); -ELEMENTS[62059] = Fluid3D([16651,16460,16291,16005],0); -ELEMENTS[62060] = Fluid3D([5984,6627,5884,6206],0); -ELEMENTS[62061] = Fluid3D([4691,4809,5348,5059],0); -ELEMENTS[62062] = Fluid3D([10011,9233,10139,9457],0); -ELEMENTS[62063] = Fluid3D([3486,3109,3269,3545],0); -ELEMENTS[62064] = Fluid3D([2772,2595,2886,2945],0); -ELEMENTS[62065] = Fluid3D([2595,2886,2945,3013],0); -ELEMENTS[62066] = Fluid3D([2886,2945,3013,3267],0); -ELEMENTS[62067] = Fluid3D([2945,2595,3013,3026],0); -ELEMENTS[62068] = Fluid3D([3013,2945,3026,3073],0); -ELEMENTS[62069] = Fluid3D([2945,3026,3073,2725],0); -ELEMENTS[62070] = Fluid3D([2945,3026,2725,2595],0); -ELEMENTS[62071] = Fluid3D([3013,2945,3073,3267],0); -ELEMENTS[62072] = Fluid3D([3026,3013,3073,3267],0); -ELEMENTS[62073] = Fluid3D([2945,3073,3267,3094],0); -ELEMENTS[62074] = Fluid3D([2595,3013,3026,2956],0); -ELEMENTS[62075] = Fluid3D([3013,3026,2956,3273],0); -ELEMENTS[62076] = Fluid3D([2886,2772,2945,3094],0); -ELEMENTS[62077] = Fluid3D([2772,2595,2945,2725],0); -ELEMENTS[62078] = Fluid3D([2956,3013,3273,2944],0); -ELEMENTS[62079] = Fluid3D([2956,3013,2944,2595],0); -ELEMENTS[62080] = Fluid3D([17370,17745,17668,17563],0); -ELEMENTS[62081] = Fluid3D([12816,13383,13771,13851],0); -ELEMENTS[62082] = Fluid3D([15460,15883,15750,15052],0); -ELEMENTS[62083] = Fluid3D([13806,13681,12888,13435],0); -ELEMENTS[62084] = Fluid3D([5191,5795,5604,5916],0); -ELEMENTS[62085] = Fluid3D([10468,9686,9884,9181],0); -ELEMENTS[62086] = Fluid3D([18545,18594,18512,18460],0); -ELEMENTS[62087] = Fluid3D([17795,17636,17565,17895],0); -ELEMENTS[62088] = Fluid3D([17636,17565,17895,17558],0); -ELEMENTS[62089] = Fluid3D([17895,17636,17558,17715],0); -ELEMENTS[62090] = Fluid3D([17636,17565,17558,17258],0); -ELEMENTS[62091] = Fluid3D([17558,17636,17258,17419],0); -ELEMENTS[62092] = Fluid3D([17636,17558,17715,17419],0); -ELEMENTS[62093] = Fluid3D([17795,17636,17895,17827],0); -ELEMENTS[62094] = Fluid3D([17636,17895,17827,17715],0); -ELEMENTS[62095] = Fluid3D([3748,3825,4166,3942],0); -ELEMENTS[62096] = Fluid3D([17158,16993,17300,16601],0); -ELEMENTS[62097] = Fluid3D([16586,16220,16439,16043],0); -ELEMENTS[62098] = Fluid3D([16220,16439,16043,15889],0); -ELEMENTS[62099] = Fluid3D([16439,16043,15889,15965],0); -ELEMENTS[62100] = Fluid3D([16043,15889,15965,15468],0); -ELEMENTS[62101] = Fluid3D([16439,16043,15965,16586],0); -ELEMENTS[62102] = Fluid3D([16586,16220,16043,15798],0); -ELEMENTS[62103] = Fluid3D([16043,15889,15468,16220],0); -ELEMENTS[62104] = Fluid3D([16043,15965,16586,16132],0); -ELEMENTS[62105] = Fluid3D([16043,15965,16132,15798],0); -ELEMENTS[62106] = Fluid3D([16043,15965,15798,15468],0); -ELEMENTS[62107] = Fluid3D([15798,16043,15468,16220],0); -ELEMENTS[62108] = Fluid3D([6054,6769,6573,5856],0); -ELEMENTS[62109] = Fluid3D([6573,6054,5856,5920],0); -ELEMENTS[62110] = Fluid3D([2027,2212,2130,2403],0); -ELEMENTS[62111] = Fluid3D([4604,5146,4876,5159],0); -ELEMENTS[62112] = Fluid3D([14620,14124,14323,13715],0); -ELEMENTS[62113] = Fluid3D([6315,7149,7072,7306],0); -ELEMENTS[62114] = Fluid3D([13283,13087,12399,12357],0); -ELEMENTS[62115] = Fluid3D([12599,11670,11930,12368],0); -ELEMENTS[62116] = Fluid3D([18483,18439,18541,18334],0); -ELEMENTS[62117] = Fluid3D([2022,1969,2132,2224],0); -ELEMENTS[62118] = Fluid3D([13524,13601,13104,12416],0); -ELEMENTS[62119] = Fluid3D([15207,14794,14841,14589],0); -ELEMENTS[62120] = Fluid3D([2851,3183,3070,3335],0); -ELEMENTS[62121] = Fluid3D([2477,2611,2357,2727],0); -ELEMENTS[62122] = Fluid3D([8359,8033,8375,8530],0); -ELEMENTS[62123] = Fluid3D([8359,8033,8530,7581],0); -ELEMENTS[62124] = Fluid3D([8033,8375,8530,8763],0); -ELEMENTS[62125] = Fluid3D([4755,4384,4010,4231],0); -ELEMENTS[62126] = Fluid3D([17686,17276,17442,17131],0); -ELEMENTS[62127] = Fluid3D([17064,16736,16858,16500],0); -ELEMENTS[62128] = Fluid3D([6037,6949,6137,6892],0); -ELEMENTS[62129] = Fluid3D([15218,14977,14459,14947],0); -ELEMENTS[62130] = Fluid3D([14913,15262,15342,14521],0); -ELEMENTS[62131] = Fluid3D([15330,15623,15206,14834],0); -ELEMENTS[62132] = Fluid3D([5221,5142,4703,4754],0); -ELEMENTS[62133] = Fluid3D([9757,9563,8853,8675],0); -ELEMENTS[62134] = Fluid3D([2650,2962,2763,2710],0); -ELEMENTS[62135] = Fluid3D([11514,11959,11231,10761],0); -ELEMENTS[62136] = Fluid3D([9051,9440,9696,8622],0); -ELEMENTS[62137] = Fluid3D([6745,6493,7040,7431],0); -ELEMENTS[62138] = Fluid3D([17039,16986,16585,16800],0); -ELEMENTS[62139] = Fluid3D([17723,17639,17459,17094],0); -ELEMENTS[62140] = Fluid3D([15057,14814,14309,15551],0); -ELEMENTS[62141] = Fluid3D([16127,15743,16047,15700],0); -ELEMENTS[62142] = Fluid3D([16047,16127,15700,16398],0); -ELEMENTS[62143] = Fluid3D([15700,16047,16398,15898],0); -ELEMENTS[62144] = Fluid3D([15035,15090,14525,14854],0); -ELEMENTS[62145] = Fluid3D([3219,3002,2878,3433],0); -ELEMENTS[62146] = Fluid3D([15980,15663,15595,15476],0); -ELEMENTS[62147] = Fluid3D([3847,4147,3716,4207],0); -ELEMENTS[62148] = Fluid3D([17364,17552,17446,17103],0); -ELEMENTS[62149] = Fluid3D([13105,12632,12710,12024],0); -ELEMENTS[62150] = Fluid3D([13286,13037,12286,13408],0); -ELEMENTS[62151] = Fluid3D([7374,8368,7904,7837],0); -ELEMENTS[62152] = Fluid3D([16359,16153,16526,16004],0); -ELEMENTS[62153] = Fluid3D([16526,16359,16004,16124],0); -ELEMENTS[62154] = Fluid3D([16359,16153,16004,15423],0); -ELEMENTS[62155] = Fluid3D([16153,16526,16004,15642],0); -ELEMENTS[62156] = Fluid3D([16004,16153,15642,15423],0); -ELEMENTS[62157] = Fluid3D([15642,16004,15423,15714],0); -ELEMENTS[62158] = Fluid3D([15642,16004,15714,15703],0); -ELEMENTS[62159] = Fluid3D([16004,15423,15714,16359],0); -ELEMENTS[62160] = Fluid3D([16359,16004,16124,15714],0); -ELEMENTS[62161] = Fluid3D([16004,16124,15714,16145],0); -ELEMENTS[62162] = Fluid3D([16004,16124,16145,16526],0); -ELEMENTS[62163] = Fluid3D([16526,16004,15642,16254],0); -ELEMENTS[62164] = Fluid3D([6890,6217,6297,6459],0); -ELEMENTS[62165] = Fluid3D([8817,8595,7955,8996],0); -ELEMENTS[62166] = Fluid3D([9357,10079,9353,9516],0); -ELEMENTS[62167] = Fluid3D([17395,17124,17376,16910],0); -ELEMENTS[62168] = Fluid3D([13948,13623,14559,14891],0); -ELEMENTS[62169] = Fluid3D([14559,13948,14891,14495],0); -ELEMENTS[62170] = Fluid3D([9547,9829,10517,9884],0); -ELEMENTS[62171] = Fluid3D([17822,18142,18051,17970],0); -ELEMENTS[62172] = Fluid3D([15659,15917,16062,15122],0); -ELEMENTS[62173] = Fluid3D([13980,13931,13531,13090],0); -ELEMENTS[62174] = Fluid3D([4463,4330,4858,4508],0); -ELEMENTS[62175] = Fluid3D([6046,5430,5604,6194],0); -ELEMENTS[62176] = Fluid3D([18080,17926,17869,17623],0); -ELEMENTS[62177] = Fluid3D([8835,8128,8015,8376],0); -ELEMENTS[62178] = Fluid3D([8128,8015,8376,7330],0); -ELEMENTS[62179] = Fluid3D([18609,18639,18577,18600],0); -ELEMENTS[62180] = Fluid3D([18609,18639,18600,18663],0); -ELEMENTS[62181] = Fluid3D([18595,18555,18517,18452],0); -ELEMENTS[62182] = Fluid3D([4426,4861,4386,4699],0); -ELEMENTS[62183] = Fluid3D([15645,15443,14892,15014],0); -ELEMENTS[62184] = Fluid3D([2312,2204,2106,2463],0); -ELEMENTS[62185] = Fluid3D([18465,18339,18369,18288],0); -ELEMENTS[62186] = Fluid3D([4207,4907,4552,4194],0); -ELEMENTS[62187] = Fluid3D([4552,4207,4194,4031],0); -ELEMENTS[62188] = Fluid3D([15521,15283,15711,15017],0); -ELEMENTS[62189] = Fluid3D([15711,15521,15017,15441],0); -ELEMENTS[62190] = Fluid3D([15521,15283,15017,14751],0); -ELEMENTS[62191] = Fluid3D([15017,15521,14751,14941],0); -ELEMENTS[62192] = Fluid3D([3435,3376,3752,3550],0); -ELEMENTS[62193] = Fluid3D([14519,14308,13706,13913],0); -ELEMENTS[62194] = Fluid3D([13044,12755,13928,13494],0); -ELEMENTS[62195] = Fluid3D([7292,6928,7756,7772],0); -ELEMENTS[62196] = Fluid3D([14439,14937,14061,15182],0); -ELEMENTS[62197] = Fluid3D([7593,8622,8075,7731],0); -ELEMENTS[62198] = Fluid3D([9271,9429,10318,10074],0); -ELEMENTS[62199] = Fluid3D([9271,9429,10074,8582],0); -ELEMENTS[62200] = Fluid3D([13378,13650,13132,12293],0); -ELEMENTS[62201] = Fluid3D([10925,10367,11667,10225],0); -ELEMENTS[62202] = Fluid3D([16529,17030,16775,16304],0); -ELEMENTS[62203] = Fluid3D([13727,14232,14037,13275],0); -ELEMENTS[62204] = Fluid3D([2828,2654,2980,2843],0); -ELEMENTS[62205] = Fluid3D([15493,16166,15973,15935],0); -ELEMENTS[62206] = Fluid3D([17611,17347,17411,17207],0); -ELEMENTS[62207] = Fluid3D([18497,18409,18373,18355],0); -ELEMENTS[62208] = Fluid3D([17572,17717,17377,17766],0); -ELEMENTS[62209] = Fluid3D([1995,2028,1876,2126],0); -ELEMENTS[62210] = Fluid3D([14374,13516,14021,13606],0); -ELEMENTS[62211] = Fluid3D([6693,6022,6118,7146],0); -ELEMENTS[62212] = Fluid3D([4276,3930,3835,4292],0); -ELEMENTS[62213] = Fluid3D([17617,17422,17359,17215],0); -ELEMENTS[62214] = Fluid3D([18528,18504,18414,18571],0); -ELEMENTS[62215] = Fluid3D([16448,16952,16851,16686],0); -ELEMENTS[62216] = Fluid3D([10113,11186,10781,11382],0); -ELEMENTS[62217] = Fluid3D([18209,18170,18027,17992],0); -ELEMENTS[62218] = Fluid3D([14558,14323,14056,13789],0); -ELEMENTS[62219] = Fluid3D([3476,3358,3755,4007],0); -ELEMENTS[62220] = Fluid3D([16737,17000,17055,16358],0); -ELEMENTS[62221] = Fluid3D([8573,9014,9877,9902],0); -ELEMENTS[62222] = Fluid3D([13052,12062,12977,13161],0); -ELEMENTS[62223] = Fluid3D([12977,13052,13161,14103],0); -ELEMENTS[62224] = Fluid3D([4284,4027,4510,4503],0); -ELEMENTS[62225] = Fluid3D([4284,4027,4503,4165],0); -ELEMENTS[62226] = Fluid3D([4503,4284,4165,4613],0); -ELEMENTS[62227] = Fluid3D([4165,4503,4613,4279],0); -ELEMENTS[62228] = Fluid3D([4503,4613,4279,4555],0); -ELEMENTS[62229] = Fluid3D([4503,4613,4555,4973],0); -ELEMENTS[62230] = Fluid3D([4503,4613,4973,4284],0); -ELEMENTS[62231] = Fluid3D([4555,4503,4973,4510],0); -ELEMENTS[62232] = Fluid3D([4555,4503,4510,4027],0); -ELEMENTS[62233] = Fluid3D([4279,4503,4555,4027],0); -ELEMENTS[62234] = Fluid3D([4973,4555,4510,4762],0); -ELEMENTS[62235] = Fluid3D([4503,4973,4510,4284],0); -ELEMENTS[62236] = Fluid3D([4613,4165,4279,3919],0); -ELEMENTS[62237] = Fluid3D([4165,4279,3919,3818],0); -ELEMENTS[62238] = Fluid3D([4279,4613,3919,4631],0); -ELEMENTS[62239] = Fluid3D([3919,4279,4631,4727],0); -ELEMENTS[62240] = Fluid3D([4279,4613,4631,4727],0); -ELEMENTS[62241] = Fluid3D([4165,4503,4279,4027],0); -ELEMENTS[62242] = Fluid3D([4613,4555,4973,5026],0); -ELEMENTS[62243] = Fluid3D([4555,4973,5026,4593],0); -ELEMENTS[62244] = Fluid3D([5026,4555,4593,4854],0); -ELEMENTS[62245] = Fluid3D([4613,4555,5026,4279],0); -ELEMENTS[62246] = Fluid3D([3919,4279,4727,4441],0); -ELEMENTS[62247] = Fluid3D([5026,4555,4854,4441],0); -ELEMENTS[62248] = Fluid3D([18435,18538,18519,18421],0); -ELEMENTS[62249] = Fluid3D([7453,8293,8025,7191],0); -ELEMENTS[62250] = Fluid3D([10767,11501,11954,11451],0); -ELEMENTS[62251] = Fluid3D([8268,8642,7756,8587],0); -ELEMENTS[62252] = Fluid3D([18660,18616,18647,18574],0); -ELEMENTS[62253] = Fluid3D([14175,13679,13801,13321],0); -ELEMENTS[62254] = Fluid3D([12309,12316,11466,11811],0); -ELEMENTS[62255] = Fluid3D([9459,9826,9379,10240],0); -ELEMENTS[62256] = Fluid3D([16745,17006,16695,17119],0); -ELEMENTS[62257] = Fluid3D([16745,17006,17119,17389],0); -ELEMENTS[62258] = Fluid3D([17006,17119,17389,17315],0); -ELEMENTS[62259] = Fluid3D([17119,17389,17315,17144],0); -ELEMENTS[62260] = Fluid3D([17006,17119,17315,16695],0); -ELEMENTS[62261] = Fluid3D([16695,16745,17119,16917],0); -ELEMENTS[62262] = Fluid3D([16745,17119,16917,17250],0); -ELEMENTS[62263] = Fluid3D([17119,16695,16917,17144],0); -ELEMENTS[62264] = Fluid3D([16917,17119,17144,17265],0); -ELEMENTS[62265] = Fluid3D([16917,17119,17265,17250],0); -ELEMENTS[62266] = Fluid3D([17144,16917,17265,17508],0); -ELEMENTS[62267] = Fluid3D([17119,17144,17265,17389],0); -ELEMENTS[62268] = Fluid3D([17265,17119,17389,17250],0); -ELEMENTS[62269] = Fluid3D([17389,17265,17250,17508],0); -ELEMENTS[62270] = Fluid3D([17265,16917,17250,17508],0); -ELEMENTS[62271] = Fluid3D([17389,17265,17508,17556],0); -ELEMENTS[62272] = Fluid3D([17389,17265,17556,17144],0); -ELEMENTS[62273] = Fluid3D([17119,17389,17250,16745],0); -ELEMENTS[62274] = Fluid3D([17265,17556,17144,17508],0); -ELEMENTS[62275] = Fluid3D([17119,17315,16695,17144],0); -ELEMENTS[62276] = Fluid3D([11779,12790,12579,12476],0); -ELEMENTS[62277] = Fluid3D([17413,17142,17167,17102],0); -ELEMENTS[62278] = Fluid3D([16841,17153,16990,16457],0); -ELEMENTS[62279] = Fluid3D([2058,2254,2175,2342],0); -ELEMENTS[62280] = Fluid3D([6878,7505,6812,6794],0); -ELEMENTS[62281] = Fluid3D([2595,2349,2449,2651],0); -ELEMENTS[62282] = Fluid3D([15531,15178,14824,15581],0); -ELEMENTS[62283] = Fluid3D([15178,14824,15581,15344],0); -ELEMENTS[62284] = Fluid3D([15531,15178,15581,15947],0); -ELEMENTS[62285] = Fluid3D([15178,15581,15947,15344],0); -ELEMENTS[62286] = Fluid3D([15581,15947,15344,15636],0); -ELEMENTS[62287] = Fluid3D([15344,15581,15636,15513],0); -ELEMENTS[62288] = Fluid3D([15581,15636,15513,16179],0); -ELEMENTS[62289] = Fluid3D([15581,15947,15636,16179],0); -ELEMENTS[62290] = Fluid3D([15513,15581,16179,15947],0); -ELEMENTS[62291] = Fluid3D([15513,15581,15947,15531],0); -ELEMENTS[62292] = Fluid3D([15513,15581,15531,14824],0); -ELEMENTS[62293] = Fluid3D([15513,15581,14824,15344],0); -ELEMENTS[62294] = Fluid3D([6075,5444,5712,5811],0); -ELEMENTS[62295] = Fluid3D([16267,15660,15869,15641],0); -ELEMENTS[62296] = Fluid3D([10750,10031,9777,10814],0); -ELEMENTS[62297] = Fluid3D([10702,10779,11714,11203],0); -ELEMENTS[62298] = Fluid3D([6581,6078,5918,6102],0); -ELEMENTS[62299] = Fluid3D([17953,17990,17766,17666],0); -ELEMENTS[62300] = Fluid3D([8853,9563,8662,8646],0); -ELEMENTS[62301] = Fluid3D([9563,8662,8646,8898],0); -ELEMENTS[62302] = Fluid3D([8853,9563,8646,8675],0); -ELEMENTS[62303] = Fluid3D([8662,8853,8646,7932],0); -ELEMENTS[62304] = Fluid3D([8646,8662,7932,8898],0); -ELEMENTS[62305] = Fluid3D([8646,9563,8898,9383],0); -ELEMENTS[62306] = Fluid3D([8898,8646,9383,8614],0); -ELEMENTS[62307] = Fluid3D([18641,18610,18657,18574],0); -ELEMENTS[62308] = Fluid3D([15285,15546,15934,15320],0); -ELEMENTS[62309] = Fluid3D([17888,17918,18089,17756],0); -ELEMENTS[62310] = Fluid3D([13587,14497,14174,14022],0); -ELEMENTS[62311] = Fluid3D([15149,15409,15583,14865],0); -ELEMENTS[62312] = Fluid3D([4617,5136,4541,4403],0); -ELEMENTS[62313] = Fluid3D([4541,4617,4403,3831],0); -ELEMENTS[62314] = Fluid3D([5136,4541,4403,4946],0); -ELEMENTS[62315] = Fluid3D([13096,12503,12603,13858],0); -ELEMENTS[62316] = Fluid3D([5371,5062,5660,5844],0); -ELEMENTS[62317] = Fluid3D([15408,15994,15938,15772],0); -ELEMENTS[62318] = Fluid3D([1839,1879,1721,1804],0); -ELEMENTS[62319] = Fluid3D([15666,15642,16254,16353],0); -ELEMENTS[62320] = Fluid3D([16254,15666,16353,16072],0); -ELEMENTS[62321] = Fluid3D([17302,17585,17418,17274],0); -ELEMENTS[62322] = Fluid3D([17302,17585,17274,17486],0); -ELEMENTS[62323] = Fluid3D([11041,11634,10627,11237],0); -ELEMENTS[62324] = Fluid3D([4081,4234,4658,4118],0); -ELEMENTS[62325] = Fluid3D([4081,4234,4118,3570],0); -ELEMENTS[62326] = Fluid3D([12760,13493,12638,12902],0); -ELEMENTS[62327] = Fluid3D([18568,18481,18543,18370],0); -ELEMENTS[62328] = Fluid3D([12832,13314,12964,12664],0); -ELEMENTS[62329] = Fluid3D([16346,15982,16042,15480],0); -ELEMENTS[62330] = Fluid3D([10822,11753,10988,11294],0); -ELEMENTS[62331] = Fluid3D([12577,12989,13587,13000],0); -ELEMENTS[62332] = Fluid3D([18126,18255,18073,17969],0); -ELEMENTS[62333] = Fluid3D([15799,16027,15607,15249],0); -ELEMENTS[62334] = Fluid3D([5668,5078,5428,5657],0); -ELEMENTS[62335] = Fluid3D([15349,15769,15518,15104],0); -ELEMENTS[62336] = Fluid3D([17416,17607,17267,17105],0); -ELEMENTS[62337] = Fluid3D([15698,14999,15285,15030],0); -ELEMENTS[62338] = Fluid3D([2400,2182,2248,2493],0); -ELEMENTS[62339] = Fluid3D([16346,16679,16632,16067],0); -ELEMENTS[62340] = Fluid3D([15154,15503,15339,15664],0); -ELEMENTS[62341] = Fluid3D([17515,17787,17470,17743],0); -ELEMENTS[62342] = Fluid3D([6714,6437,5989,7016],0); -ELEMENTS[62343] = Fluid3D([14765,14212,14977,14612],0); -ELEMENTS[62344] = Fluid3D([1939,2094,1964,2186],0); -ELEMENTS[62345] = Fluid3D([16081,15925,15411,15515],0); -ELEMENTS[62346] = Fluid3D([15411,16081,15515,15589],0); -ELEMENTS[62347] = Fluid3D([15515,15411,15589,14844],0); -ELEMENTS[62348] = Fluid3D([6261,6131,5830,6619],0); -ELEMENTS[62349] = Fluid3D([15656,15812,16090,15447],0); -ELEMENTS[62350] = Fluid3D([4632,4498,4138,4131],0); -ELEMENTS[62351] = Fluid3D([4498,4138,4131,3867],0); -ELEMENTS[62352] = Fluid3D([4131,4498,3867,4015],0); -ELEMENTS[62353] = Fluid3D([18261,18381,18400,18133],0); -ELEMENTS[62354] = Fluid3D([5414,5702,5920,5334],0); -ELEMENTS[62355] = Fluid3D([18274,18190,18086,18004],0); -ELEMENTS[62356] = Fluid3D([13278,14236,13820,14307],0); -ELEMENTS[62357] = Fluid3D([13486,13678,13165,12823],0); -ELEMENTS[62358] = Fluid3D([17804,18017,17894,17612],0); -ELEMENTS[62359] = Fluid3D([15667,15678,15360,16139],0); -ELEMENTS[62360] = Fluid3D([7843,7095,7722,7668],0); -ELEMENTS[62361] = Fluid3D([9331,10319,9870,10475],0); -ELEMENTS[62362] = Fluid3D([15227,15102,15529,14627],0); -ELEMENTS[62363] = Fluid3D([13439,12941,13073,12541],0); -ELEMENTS[62364] = Fluid3D([17989,18181,18066,17751],0); -ELEMENTS[62365] = Fluid3D([16556,16262,16588,16312],0); -ELEMENTS[62366] = Fluid3D([16588,16556,16312,16874],0); -ELEMENTS[62367] = Fluid3D([16556,16262,16312,16230],0); -ELEMENTS[62368] = Fluid3D([17235,16955,16996,16744],0); -ELEMENTS[62369] = Fluid3D([17246,17404,17685,17630],0); -ELEMENTS[62370] = Fluid3D([15932,15708,15518,15369],0); -ELEMENTS[62371] = Fluid3D([4604,4357,4892,4922],0); -ELEMENTS[62372] = Fluid3D([15700,15439,16127,15743],0); -ELEMENTS[62373] = Fluid3D([10011,10139,10947,10675],0); -ELEMENTS[62374] = Fluid3D([4815,5386,5191,5516],0); -ELEMENTS[62375] = Fluid3D([18654,18622,18604,18571],0); -ELEMENTS[62376] = Fluid3D([8256,8776,7950,8840],0); -ELEMENTS[62377] = Fluid3D([3250,2938,3224,3479],0); -ELEMENTS[62378] = Fluid3D([3224,3250,3479,3579],0); -ELEMENTS[62379] = Fluid3D([6534,7339,7128,7612],0); -ELEMENTS[62380] = Fluid3D([18341,18317,18449,18318],0); -ELEMENTS[62381] = Fluid3D([11231,11526,12286,11616],0); -ELEMENTS[62382] = Fluid3D([18624,18641,18668,18630],0); -ELEMENTS[62383] = Fluid3D([2888,3142,2826,3209],0); -ELEMENTS[62384] = Fluid3D([3250,3300,2981,3548],0); -ELEMENTS[62385] = Fluid3D([7231,7893,7114,7478],0); -ELEMENTS[62386] = Fluid3D([7765,8403,7561,7587],0); -ELEMENTS[62387] = Fluid3D([11795,11333,12005,11298],0); -ELEMENTS[62388] = Fluid3D([17016,17202,16881,16700],0); -ELEMENTS[62389] = Fluid3D([4290,4726,4156,4280],0); -ELEMENTS[62390] = Fluid3D([11827,11469,11961,10642],0); -ELEMENTS[62391] = Fluid3D([3295,3472,3719,3320],0); -ELEMENTS[62392] = Fluid3D([6395,6315,5708,5967],0); -ELEMENTS[62393] = Fluid3D([12316,13114,13130,12347],0); -ELEMENTS[62394] = Fluid3D([13736,14142,13842,13373],0); -ELEMENTS[62395] = Fluid3D([14142,13842,13373,13667],0); -ELEMENTS[62396] = Fluid3D([13736,14142,13373,13884],0); -ELEMENTS[62397] = Fluid3D([13842,13373,13667,12754],0); -ELEMENTS[62398] = Fluid3D([13373,13667,12754,12826],0); -ELEMENTS[62399] = Fluid3D([12754,13373,12826,13243],0); -ELEMENTS[62400] = Fluid3D([13373,12826,13243,13667],0); -ELEMENTS[62401] = Fluid3D([12754,13373,13243,12812],0); -ELEMENTS[62402] = Fluid3D([13373,13243,12812,13884],0); -ELEMENTS[62403] = Fluid3D([12754,13373,12812,13259],0); -ELEMENTS[62404] = Fluid3D([13373,12812,13259,13884],0); -ELEMENTS[62405] = Fluid3D([13373,13243,13884,14452],0); -ELEMENTS[62406] = Fluid3D([12812,12754,13259,12703],0); -ELEMENTS[62407] = Fluid3D([13259,12812,12703,12303],0); -ELEMENTS[62408] = Fluid3D([13259,12812,12303,13181],0); -ELEMENTS[62409] = Fluid3D([13259,12812,13181,13884],0); -ELEMENTS[62410] = Fluid3D([12812,13181,13884,13243],0); -ELEMENTS[62411] = Fluid3D([13181,13884,13243,12928],0); -ELEMENTS[62412] = Fluid3D([13181,13884,12928,12980],0); -ELEMENTS[62413] = Fluid3D([12812,12303,13181,13243],0); -ELEMENTS[62414] = Fluid3D([13181,13259,13884,13306],0); -ELEMENTS[62415] = Fluid3D([13181,13259,13306,12303],0); -ELEMENTS[62416] = Fluid3D([13884,13181,13306,13688],0); -ELEMENTS[62417] = Fluid3D([13884,13181,13688,12980],0); -ELEMENTS[62418] = Fluid3D([12928,13181,12980,12303],0); -ELEMENTS[62419] = Fluid3D([13243,13181,12928,12303],0); -ELEMENTS[62420] = Fluid3D([13884,13243,12928,13959],0); -ELEMENTS[62421] = Fluid3D([13181,13688,12980,12303],0); -ELEMENTS[62422] = Fluid3D([13243,13373,13667,14452],0); -ELEMENTS[62423] = Fluid3D([12812,12703,12303,11545],0); -ELEMENTS[62424] = Fluid3D([13181,13306,13688,12303],0); -ELEMENTS[62425] = Fluid3D([13842,13373,12754,13736],0); -ELEMENTS[62426] = Fluid3D([2201,2132,2344,2279],0); -ELEMENTS[62427] = Fluid3D([18629,18542,18573,18518],0); -ELEMENTS[62428] = Fluid3D([2776,2954,2987,3025],0); -ELEMENTS[62429] = Fluid3D([15924,15597,16224,15861],0); -ELEMENTS[62430] = Fluid3D([2355,2477,2235,2453],0); -ELEMENTS[62431] = Fluid3D([7529,8385,8078,8347],0); -ELEMENTS[62432] = Fluid3D([13344,13086,12453,12916],0); -ELEMENTS[62433] = Fluid3D([18193,18106,18291,17919],0); -ELEMENTS[62434] = Fluid3D([18193,18106,17919,18002],0); -ELEMENTS[62435] = Fluid3D([14064,14532,14450,13711],0); -ELEMENTS[62436] = Fluid3D([15784,15636,15067,15344],0); -ELEMENTS[62437] = Fluid3D([3815,4022,3589,4222],0); -ELEMENTS[62438] = Fluid3D([13834,14282,13420,13329],0); -ELEMENTS[62439] = Fluid3D([2955,2931,2676,3065],0); -ELEMENTS[62440] = Fluid3D([16114,15895,16293,15461],0); -ELEMENTS[62441] = Fluid3D([5608,6260,6240,6110],0); -ELEMENTS[62442] = Fluid3D([13905,13638,13395,12715],0); -ELEMENTS[62443] = Fluid3D([9214,10130,9206,9461],0); -ELEMENTS[62444] = Fluid3D([8729,8636,9489,9612],0); -ELEMENTS[62445] = Fluid3D([3193,3012,3393,3460],0); -ELEMENTS[62446] = Fluid3D([15662,16244,16144,15741],0); -ELEMENTS[62447] = Fluid3D([8031,8583,7718,7269],0); -ELEMENTS[62448] = Fluid3D([8634,9621,8905,9902],0); -ELEMENTS[62449] = Fluid3D([15984,16410,16074,16674],0); -ELEMENTS[62450] = Fluid3D([17598,17707,17971,17691],0); -ELEMENTS[62451] = Fluid3D([14792,14306,14668,13973],0); -ELEMENTS[62452] = Fluid3D([9121,8139,9050,9141],0); -ELEMENTS[62453] = Fluid3D([14049,14624,14263,13701],0); -ELEMENTS[62454] = Fluid3D([14049,14624,13701,14546],0); -ELEMENTS[62455] = Fluid3D([15851,16075,15742,16332],0); -ELEMENTS[62456] = Fluid3D([15982,15940,15601,15480],0); -ELEMENTS[62457] = Fluid3D([4166,3825,4263,4170],0); -ELEMENTS[62458] = Fluid3D([4075,4518,4175,4388],0); -ELEMENTS[62459] = Fluid3D([4075,4518,4388,4924],0); -ELEMENTS[62460] = Fluid3D([6753,7506,7440,6725],0); -ELEMENTS[62461] = Fluid3D([1681,1606,1706,1783],0); -ELEMENTS[62462] = Fluid3D([16110,16571,16765,16821],0); -ELEMENTS[62463] = Fluid3D([16571,16765,16821,16912],0); -ELEMENTS[62464] = Fluid3D([16821,16571,16912,16366],0); -ELEMENTS[62465] = Fluid3D([4571,4885,4355,5065],0); -ELEMENTS[62466] = Fluid3D([10625,10771,11489,10458],0); -ELEMENTS[62467] = Fluid3D([15608,16026,15883,15295],0); -ELEMENTS[62468] = Fluid3D([13486,13796,13977,12823],0); -ELEMENTS[62469] = Fluid3D([8806,8125,8429,7616],0); -ELEMENTS[62470] = Fluid3D([6472,7228,6560,7233],0); -ELEMENTS[62471] = Fluid3D([18409,18266,18373,18158],0); -ELEMENTS[62472] = Fluid3D([2713,2620,2823,3052],0); -ELEMENTS[62473] = Fluid3D([18619,18645,18594,18572],0); -ELEMENTS[62474] = Fluid3D([10701,11324,10624,10493],0); -ELEMENTS[62475] = Fluid3D([10701,11324,10493,11335],0); -ELEMENTS[62476] = Fluid3D([10493,10701,11335,11089],0); -ELEMENTS[62477] = Fluid3D([10701,11324,11335,11089],0); -ELEMENTS[62478] = Fluid3D([11879,11089,11148,11335],0); -ELEMENTS[62479] = Fluid3D([11879,11089,11335,11324],0); -ELEMENTS[62480] = Fluid3D([11089,11148,11335,10493],0); -ELEMENTS[62481] = Fluid3D([10624,10701,10493,10290],0); -ELEMENTS[62482] = Fluid3D([16180,16413,16766,16539],0); -ELEMENTS[62483] = Fluid3D([3748,3429,3825,3942],0); -ELEMENTS[62484] = Fluid3D([2235,2137,2355,2453],0); -ELEMENTS[62485] = Fluid3D([16376,16220,16586,15798],0); -ELEMENTS[62486] = Fluid3D([6961,6769,6209,6304],0); -ELEMENTS[62487] = Fluid3D([17081,17295,17386,16932],0); -ELEMENTS[62488] = Fluid3D([5767,5629,6245,6431],0); -ELEMENTS[62489] = Fluid3D([17262,17559,17459,17183],0); -ELEMENTS[62490] = Fluid3D([2602,2502,2849,2647],0); -ELEMENTS[62491] = Fluid3D([18540,18605,18531,18416],0); -ELEMENTS[62492] = Fluid3D([4892,5457,5146,5469],0); -ELEMENTS[62493] = Fluid3D([12618,12072,13018,12433],0); -ELEMENTS[62494] = Fluid3D([12925,13774,13616,13198],0); -ELEMENTS[62495] = Fluid3D([11670,11418,10700,12368],0); -ELEMENTS[62496] = Fluid3D([6396,6646,6748,7299],0); -ELEMENTS[62497] = Fluid3D([9701,10069,10545,10269],0); -ELEMENTS[62498] = Fluid3D([9701,10069,10269,9259],0); -ELEMENTS[62499] = Fluid3D([10069,10269,9259,10325],0); -ELEMENTS[62500] = Fluid3D([10069,10269,10325,11175],0); -ELEMENTS[62501] = Fluid3D([10069,10545,10269,11391],0); -ELEMENTS[62502] = Fluid3D([10069,10269,11175,11391],0); -ELEMENTS[62503] = Fluid3D([13979,13524,13908,12762],0); -ELEMENTS[62504] = Fluid3D([15170,14794,15207,14589],0); -ELEMENTS[62505] = Fluid3D([18453,18260,18331,18380],0); -ELEMENTS[62506] = Fluid3D([16813,16462,16550,16133],0); -ELEMENTS[62507] = Fluid3D([17453,17460,17522,17820],0); -ELEMENTS[62508] = Fluid3D([17453,17460,17820,17781],0); -ELEMENTS[62509] = Fluid3D([10834,11162,11713,11332],0); -ELEMENTS[62510] = Fluid3D([16540,16249,16210,15826],0); -ELEMENTS[62511] = Fluid3D([11402,12120,12461,10795],0); -ELEMENTS[62512] = Fluid3D([3778,3737,4220,4150],0); -ELEMENTS[62513] = Fluid3D([6264,6169,6984,6615],0); -ELEMENTS[62514] = Fluid3D([15660,14977,15218,15303],0); -ELEMENTS[62515] = Fluid3D([18441,18379,18506,18223],0); -ELEMENTS[62516] = Fluid3D([5926,6225,5360,5452],0); -ELEMENTS[62517] = Fluid3D([14913,14833,15262,14374],0); -ELEMENTS[62518] = Fluid3D([5705,5620,5142,4873],0); -ELEMENTS[62519] = Fluid3D([8416,8169,7569,8333],0); -ELEMENTS[62520] = Fluid3D([7314,6503,7051,7623],0); -ELEMENTS[62521] = Fluid3D([18527,18479,18410,18375],0); -ELEMENTS[62522] = Fluid3D([2962,3306,3090,3292],0); -ELEMENTS[62523] = Fluid3D([2962,3306,3292,3207],0); -ELEMENTS[62524] = Fluid3D([3748,3375,3429,3942],0); -ELEMENTS[62525] = Fluid3D([13356,14044,13246,13419],0); -ELEMENTS[62526] = Fluid3D([13246,13356,13419,12960],0); -ELEMENTS[62527] = Fluid3D([13356,13419,12960,14135],0); -ELEMENTS[62528] = Fluid3D([3930,3632,3523,3959],0); -ELEMENTS[62529] = Fluid3D([10603,9657,10639,10387],0); -ELEMENTS[62530] = Fluid3D([15900,15579,15145,15653],0); -ELEMENTS[62531] = Fluid3D([16824,17055,17133,16589],0); -ELEMENTS[62532] = Fluid3D([4407,4556,4103,4821],0); -ELEMENTS[62533] = Fluid3D([4556,4103,4821,4482],0); -ELEMENTS[62534] = Fluid3D([17968,17723,17819,17610],0); -ELEMENTS[62535] = Fluid3D([5152,4473,4731,4469],0); -ELEMENTS[62536] = Fluid3D([4094,3883,4237,4451],0); -ELEMENTS[62537] = Fluid3D([3883,4237,4451,4121],0); -ELEMENTS[62538] = Fluid3D([14410,13923,14076,13354],0); -ELEMENTS[62539] = Fluid3D([15743,15663,16047,15395],0); -ELEMENTS[62540] = Fluid3D([15663,16047,15395,15476],0); -ELEMENTS[62541] = Fluid3D([15743,15663,15395,14883],0); -ELEMENTS[62542] = Fluid3D([15395,15743,14883,14946],0); -ELEMENTS[62543] = Fluid3D([14883,15395,14946,14951],0); -ELEMENTS[62544] = Fluid3D([14883,15395,14951,15663],0); -ELEMENTS[62545] = Fluid3D([14946,14883,14951,14358],0); -ELEMENTS[62546] = Fluid3D([15395,14946,14951,15476],0); -ELEMENTS[62547] = Fluid3D([15395,14946,15476,15700],0); -ELEMENTS[62548] = Fluid3D([15395,14946,15700,15743],0); -ELEMENTS[62549] = Fluid3D([15476,15395,15700,16047],0); -ELEMENTS[62550] = Fluid3D([15395,15700,16047,15743],0); -ELEMENTS[62551] = Fluid3D([15395,14951,15663,15476],0); -ELEMENTS[62552] = Fluid3D([13616,14281,13493,13480],0); -ELEMENTS[62553] = Fluid3D([3993,4317,3847,4434],0); -ELEMENTS[62554] = Fluid3D([13972,13763,13037,13288],0); -ELEMENTS[62555] = Fluid3D([14668,14189,14542,13683],0); -ELEMENTS[62556] = Fluid3D([18125,18184,18351,18212],0); -ELEMENTS[62557] = Fluid3D([18621,18576,18636,18582],0); -ELEMENTS[62558] = Fluid3D([6781,6306,5887,6711],0); -ELEMENTS[62559] = Fluid3D([4744,4145,4427,4516],0); -ELEMENTS[62560] = Fluid3D([7607,8432,8261,8426],0); -ELEMENTS[62561] = Fluid3D([4835,4411,4365,4884],0); -ELEMENTS[62562] = Fluid3D([7340,6530,7299,6802],0); -ELEMENTS[62563] = Fluid3D([3040,2723,2855,2944],0); -ELEMENTS[62564] = Fluid3D([3040,2723,2944,2886],0); -ELEMENTS[62565] = Fluid3D([2723,2855,2944,2686],0); -ELEMENTS[62566] = Fluid3D([2767,3068,3139,2811],0); -ELEMENTS[62567] = Fluid3D([9050,8642,9594,9460],0); -ELEMENTS[62568] = Fluid3D([9050,8642,9460,9141],0); -ELEMENTS[62569] = Fluid3D([9594,9050,9460,10195],0); -ELEMENTS[62570] = Fluid3D([9460,9594,10195,9725],0); -ELEMENTS[62571] = Fluid3D([8642,9594,9460,9725],0); -ELEMENTS[62572] = Fluid3D([10195,9460,9725,9890],0); -ELEMENTS[62573] = Fluid3D([10195,9460,9890,9050],0); -ELEMENTS[62574] = Fluid3D([9460,9890,9050,9141],0); -ELEMENTS[62575] = Fluid3D([9460,9890,9141,9725],0); -ELEMENTS[62576] = Fluid3D([9141,9460,9725,8587],0); -ELEMENTS[62577] = Fluid3D([17822,17551,17928,17644],0); -ELEMENTS[62578] = Fluid3D([15501,15233,15068,14514],0); -ELEMENTS[62579] = Fluid3D([5396,4844,4811,5002],0); -ELEMENTS[62580] = Fluid3D([18410,18326,18314,18183],0); -ELEMENTS[62581] = Fluid3D([12380,11901,11177,11345],0); -ELEMENTS[62582] = Fluid3D([10314,9952,9220,10058],0); -ELEMENTS[62583] = Fluid3D([18690,18680,18694,18681],0); -ELEMENTS[62584] = Fluid3D([18026,18196,17796,17947],0); -ELEMENTS[62585] = Fluid3D([7445,7153,8148,7775],0); -ELEMENTS[62586] = Fluid3D([10349,10335,11381,11289],0); -ELEMENTS[62587] = Fluid3D([15406,15752,15059,15225],0); -ELEMENTS[62588] = Fluid3D([16916,17240,17043,16906],0); -ELEMENTS[62589] = Fluid3D([5890,6558,6165,5869],0); -ELEMENTS[62590] = Fluid3D([14823,14323,14558,14027],0); -ELEMENTS[62591] = Fluid3D([6162,6928,6465,7198],0); -ELEMENTS[62592] = Fluid3D([9244,9427,10284,9556],0); -ELEMENTS[62593] = Fluid3D([2368,2207,2160,2425],0); -ELEMENTS[62594] = Fluid3D([15118,15142,14435,14331],0); -ELEMENTS[62595] = Fluid3D([15840,16385,15944,15899],0); -ELEMENTS[62596] = Fluid3D([15944,15840,15899,15308],0); -ELEMENTS[62597] = Fluid3D([1992,1967,1848,2071],0); -ELEMENTS[62598] = Fluid3D([8552,7898,7706,7817],0); -ELEMENTS[62599] = Fluid3D([15288,14995,15440,14762],0); -ELEMENTS[62600] = Fluid3D([15288,14995,14762,14267],0); -ELEMENTS[62601] = Fluid3D([14995,14762,14267,14339],0); -ELEMENTS[62602] = Fluid3D([14762,14267,14339,14544],0); -ELEMENTS[62603] = Fluid3D([14762,14267,14544,15288],0); -ELEMENTS[62604] = Fluid3D([14339,14762,14544,14888],0); -ELEMENTS[62605] = Fluid3D([14762,14544,14888,15440],0); -ELEMENTS[62606] = Fluid3D([14267,14339,14544,13642],0); -ELEMENTS[62607] = Fluid3D([14339,14762,14888,15440],0); -ELEMENTS[62608] = Fluid3D([14544,14762,15288,15440],0); -ELEMENTS[62609] = Fluid3D([14995,15440,14762,14339],0); -ELEMENTS[62610] = Fluid3D([14544,14339,14888,13642],0); -ELEMENTS[62611] = Fluid3D([18168,18259,18343,18096],0); -ELEMENTS[62612] = Fluid3D([16239,16495,15920,15795],0); -ELEMENTS[62613] = Fluid3D([15857,15440,15607,14992],0); -ELEMENTS[62614] = Fluid3D([4454,4162,4664,4487],0); -ELEMENTS[62615] = Fluid3D([4454,4162,4487,3980],0); -ELEMENTS[62616] = Fluid3D([1874,2025,1992,2047],0); -ELEMENTS[62617] = Fluid3D([17112,16962,16639,16470],0); -ELEMENTS[62618] = Fluid3D([17482,17196,17266,16913],0); -ELEMENTS[62619] = Fluid3D([9165,8337,8153,9393],0); -ELEMENTS[62620] = Fluid3D([8385,8979,8078,8347],0); -ELEMENTS[62621] = Fluid3D([12842,13497,12604,12208],0); -ELEMENTS[62622] = Fluid3D([10003,9673,10664,10065],0); -ELEMENTS[62623] = Fluid3D([13759,13597,13947,14642],0); -ELEMENTS[62624] = Fluid3D([7277,7969,7139,6512],0); -ELEMENTS[62625] = Fluid3D([4919,5324,5467,5882],0); -ELEMENTS[62626] = Fluid3D([16448,15896,16031,15633],0); -ELEMENTS[62627] = Fluid3D([4054,3815,3630,4253],0); -ELEMENTS[62628] = Fluid3D([6038,6152,5522,5603],0); -ELEMENTS[62629] = Fluid3D([14736,13899,14282,13675],0); -ELEMENTS[62630] = Fluid3D([8174,8919,8745,9217],0); -ELEMENTS[62631] = Fluid3D([6232,6823,6118,7594],0); -ELEMENTS[62632] = Fluid3D([9563,9380,8662,8898],0); -ELEMENTS[62633] = Fluid3D([17287,17000,17233,16718],0); -ELEMENTS[62634] = Fluid3D([17522,17193,17584,17201],0); -ELEMENTS[62635] = Fluid3D([14928,14605,14442,14166],0); -ELEMENTS[62636] = Fluid3D([6563,6897,5945,6365],0); -ELEMENTS[62637] = Fluid3D([4640,4560,4166,4758],0); -ELEMENTS[62638] = Fluid3D([17819,18040,17968,17754],0); -ELEMENTS[62639] = Fluid3D([14137,14033,14854,14715],0); -ELEMENTS[62640] = Fluid3D([14854,14137,14715,14525],0); -ELEMENTS[62641] = Fluid3D([3286,3513,3684,3682],0); -ELEMENTS[62642] = Fluid3D([14054,13802,13559,13197],0); -ELEMENTS[62643] = Fluid3D([7506,8186,7440,7358],0); -ELEMENTS[62644] = Fluid3D([8186,7440,7358,7221],0); -ELEMENTS[62645] = Fluid3D([7440,7506,7358,6725],0); -ELEMENTS[62646] = Fluid3D([7358,7440,6725,7221],0); -ELEMENTS[62647] = Fluid3D([6725,7358,7221,7674],0); -ELEMENTS[62648] = Fluid3D([7358,7221,7674,8186],0); -ELEMENTS[62649] = Fluid3D([7506,8186,7358,7302],0); -ELEMENTS[62650] = Fluid3D([6725,7358,7674,7302],0); -ELEMENTS[62651] = Fluid3D([7358,7674,7302,8186],0); -ELEMENTS[62652] = Fluid3D([7506,7358,6725,7302],0); -ELEMENTS[62653] = Fluid3D([10220,10987,10030,10605],0); -ELEMENTS[62654] = Fluid3D([2296,2548,2456,2650],0); -ELEMENTS[62655] = Fluid3D([16503,15934,16169,16158],0); -ELEMENTS[62656] = Fluid3D([2497,2772,2664,2718],0); -ELEMENTS[62657] = Fluid3D([16137,16387,16028,15555],0); -ELEMENTS[62658] = Fluid3D([11803,12743,12453,11854],0); -ELEMENTS[62659] = Fluid3D([12743,12453,11854,12708],0); -ELEMENTS[62660] = Fluid3D([12453,11854,12708,11259],0); -ELEMENTS[62661] = Fluid3D([11854,12743,12708,12571],0); -ELEMENTS[62662] = Fluid3D([12708,11854,12571,12010],0); -ELEMENTS[62663] = Fluid3D([11854,12571,12010,11813],0); -ELEMENTS[62664] = Fluid3D([11854,12571,11813,12743],0); -ELEMENTS[62665] = Fluid3D([12571,12010,11813,12435],0); -ELEMENTS[62666] = Fluid3D([11813,12571,12435,13108],0); -ELEMENTS[62667] = Fluid3D([12571,12435,13108,12889],0); -ELEMENTS[62668] = Fluid3D([12435,13108,12889,13267],0); -ELEMENTS[62669] = Fluid3D([13108,12571,12889,13098],0); -ELEMENTS[62670] = Fluid3D([13108,12889,13267,13952],0); -ELEMENTS[62671] = Fluid3D([12889,12435,13267,13020],0); -ELEMENTS[62672] = Fluid3D([12435,13108,13267,13360],0); -ELEMENTS[62673] = Fluid3D([12571,12435,12889,12010],0); -ELEMENTS[62674] = Fluid3D([12435,13267,13020,12406],0); -ELEMENTS[62675] = Fluid3D([11813,12571,13108,12743],0); -ELEMENTS[62676] = Fluid3D([12571,12708,12010,13098],0); -ELEMENTS[62677] = Fluid3D([12571,13108,12743,12708],0); -ELEMENTS[62678] = Fluid3D([12010,11854,11813,11133],0); -ELEMENTS[62679] = Fluid3D([11854,11813,11133,12743],0); -ELEMENTS[62680] = Fluid3D([12708,11854,12010,12280],0); -ELEMENTS[62681] = Fluid3D([13267,13020,12406,13360],0); -ELEMENTS[62682] = Fluid3D([11803,12743,11854,11133],0); -ELEMENTS[62683] = Fluid3D([12453,11803,11854,11259],0); -ELEMENTS[62684] = Fluid3D([11854,11803,11133,11259],0); -ELEMENTS[62685] = Fluid3D([11133,11854,11259,12010],0); -ELEMENTS[62686] = Fluid3D([11854,11259,12010,12280],0); -ELEMENTS[62687] = Fluid3D([12010,12708,12280,13098],0); -ELEMENTS[62688] = Fluid3D([13267,12889,13020,13371],0); -ELEMENTS[62689] = Fluid3D([13020,13267,13371,14028],0); -ELEMENTS[62690] = Fluid3D([13267,13371,14028,13952],0); -ELEMENTS[62691] = Fluid3D([13267,12889,13371,13952],0); -ELEMENTS[62692] = Fluid3D([13020,13267,14028,13360],0); -ELEMENTS[62693] = Fluid3D([12889,13108,13098,13952],0); -ELEMENTS[62694] = Fluid3D([12708,11854,12280,11259],0); -ELEMENTS[62695] = Fluid3D([12571,12889,13098,12010],0); -ELEMENTS[62696] = Fluid3D([12435,13267,12406,13360],0); -ELEMENTS[62697] = Fluid3D([4885,5216,4657,5065],0); -ELEMENTS[62698] = Fluid3D([5439,5758,6073,6093],0); -ELEMENTS[62699] = Fluid3D([1639,1563,1621,1641],0); -ELEMENTS[62700] = Fluid3D([15941,16163,15777,15705],0); -ELEMENTS[62701] = Fluid3D([12679,11714,11799,12162],0); -ELEMENTS[62702] = Fluid3D([12679,11714,12162,12947],0); -ELEMENTS[62703] = Fluid3D([9003,9350,8532,9229],0); -ELEMENTS[62704] = Fluid3D([9003,9350,9229,9889],0); -ELEMENTS[62705] = Fluid3D([9229,9003,9889,9748],0); -ELEMENTS[62706] = Fluid3D([9003,9350,9889,10400],0); -ELEMENTS[62707] = Fluid3D([8532,9003,9229,8533],0); -ELEMENTS[62708] = Fluid3D([9350,9889,10400,9715],0); -ELEMENTS[62709] = Fluid3D([9350,9889,9715,9229],0); -ELEMENTS[62710] = Fluid3D([9889,9715,9229,10337],0); -ELEMENTS[62711] = Fluid3D([9715,9350,9229,8532],0); -ELEMENTS[62712] = Fluid3D([9229,9715,8532,8325],0); -ELEMENTS[62713] = Fluid3D([9715,9229,10337,9327],0); -ELEMENTS[62714] = Fluid3D([9715,9229,9327,8325],0); -ELEMENTS[62715] = Fluid3D([9981,10223,10952,9977],0); -ELEMENTS[62716] = Fluid3D([11069,10739,9952,10534],0); -ELEMENTS[62717] = Fluid3D([2490,2590,2342,2507],0); -ELEMENTS[62718] = Fluid3D([2342,2490,2507,2175],0); -ELEMENTS[62719] = Fluid3D([2590,2342,2507,2516],0); -ELEMENTS[62720] = Fluid3D([2507,2342,2175,2254],0); -ELEMENTS[62721] = Fluid3D([15328,15621,16037,15863],0); -ELEMENTS[62722] = Fluid3D([18071,17888,18089,17756],0); -ELEMENTS[62723] = Fluid3D([15820,15659,16062,15468],0); -ELEMENTS[62724] = Fluid3D([1885,1973,2043,2079],0); -ELEMENTS[62725] = Fluid3D([14317,14551,14054,13729],0); -ELEMENTS[62726] = Fluid3D([14054,14317,13729,13386],0); -ELEMENTS[62727] = Fluid3D([14317,13729,13386,13859],0); -ELEMENTS[62728] = Fluid3D([13729,13386,13859,12845],0); -ELEMENTS[62729] = Fluid3D([13859,13729,12845,13697],0); -ELEMENTS[62730] = Fluid3D([13859,13729,13697,14551],0); -ELEMENTS[62731] = Fluid3D([13729,14054,13386,13197],0); -ELEMENTS[62732] = Fluid3D([13729,13386,12845,13197],0); -ELEMENTS[62733] = Fluid3D([14317,13729,13859,14551],0); -ELEMENTS[62734] = Fluid3D([13386,13859,12845,12747],0); -ELEMENTS[62735] = Fluid3D([14551,14054,13729,14099],0); -ELEMENTS[62736] = Fluid3D([13729,13697,14551,14099],0); -ELEMENTS[62737] = Fluid3D([13729,13697,14099,13197],0); -ELEMENTS[62738] = Fluid3D([13697,14551,14099,14584],0); -ELEMENTS[62739] = Fluid3D([13729,13697,13197,12845],0); -ELEMENTS[62740] = Fluid3D([13729,14054,13197,14099],0); -ELEMENTS[62741] = Fluid3D([12441,12656,12864,12563],0); -ELEMENTS[62742] = Fluid3D([7561,8179,7361,7428],0); -ELEMENTS[62743] = Fluid3D([17422,17133,17359,16904],0); -ELEMENTS[62744] = Fluid3D([16972,16889,16836,17136],0); -ELEMENTS[62745] = Fluid3D([16972,16889,17136,17236],0); -ELEMENTS[62746] = Fluid3D([16972,16889,17236,17337],0); -ELEMENTS[62747] = Fluid3D([16972,16889,17337,17080],0); -ELEMENTS[62748] = Fluid3D([15355,15408,15938,15500],0); -ELEMENTS[62749] = Fluid3D([12601,11650,12293,12422],0); -ELEMENTS[62750] = Fluid3D([17695,17869,17926,17623],0); -ELEMENTS[62751] = Fluid3D([18256,18408,18325,18079],0); -ELEMENTS[62752] = Fluid3D([12329,12461,11960,11402],0); -ELEMENTS[62753] = Fluid3D([18516,18478,18351,18371],0); -ELEMENTS[62754] = Fluid3D([14719,15179,14895,14387],0); -ELEMENTS[62755] = Fluid3D([9590,10465,9419,9710],0); -ELEMENTS[62756] = Fluid3D([4857,5410,4500,4583],0); -ELEMENTS[62757] = Fluid3D([2130,2248,2054,2233],0); -ELEMENTS[62758] = Fluid3D([17266,17196,16974,16913],0); -ELEMENTS[62759] = Fluid3D([5538,6162,5801,5886],0); -ELEMENTS[62760] = Fluid3D([16487,16075,16616,16263],0); -ELEMENTS[62761] = Fluid3D([6412,6554,5888,6072],0); -ELEMENTS[62762] = Fluid3D([3769,3966,3990,4449],0); -ELEMENTS[62763] = Fluid3D([9067,9493,9357,10145],0); -ELEMENTS[62764] = Fluid3D([6270,5949,6745,6375],0); -ELEMENTS[62765] = Fluid3D([13813,13091,13905,14197],0); -ELEMENTS[62766] = Fluid3D([18115,18147,18286,18135],0); -ELEMENTS[62767] = Fluid3D([16155,15837,15600,16192],0); -ELEMENTS[62768] = Fluid3D([17767,17660,17450,17917],0); -ELEMENTS[62769] = Fluid3D([17767,17660,17917,17983],0); -ELEMENTS[62770] = Fluid3D([9634,9657,10603,10515],0); -ELEMENTS[62771] = Fluid3D([12305,11902,11219,11301],0); -ELEMENTS[62772] = Fluid3D([6584,7257,6500,7123],0); -ELEMENTS[62773] = Fluid3D([17427,17466,17190,17176],0); -ELEMENTS[62774] = Fluid3D([8779,8686,7737,9179],0); -ELEMENTS[62775] = Fluid3D([2173,2213,2001,2065],0); -ELEMENTS[62776] = Fluid3D([15897,16317,16287,15596],0); -ELEMENTS[62777] = Fluid3D([15897,16317,15596,15557],0); -ELEMENTS[62778] = Fluid3D([15012,15430,15102,14627],0); -ELEMENTS[62779] = Fluid3D([1960,2163,1942,2198],0); -ELEMENTS[62780] = Fluid3D([5361,5848,5852,5489],0); -ELEMENTS[62781] = Fluid3D([17698,17937,17797,17511],0); -ELEMENTS[62782] = Fluid3D([1739,1644,1705,1802],0); -ELEMENTS[62783] = Fluid3D([6945,7489,6520,6920],0); -ELEMENTS[62784] = Fluid3D([6945,7489,6920,7458],0); -ELEMENTS[62785] = Fluid3D([6520,6945,6920,6208],0); -ELEMENTS[62786] = Fluid3D([7489,6520,6920,7025],0); -ELEMENTS[62787] = Fluid3D([17436,17413,17167,17135],0); -ELEMENTS[62788] = Fluid3D([9094,9003,9660,10400],0); -ELEMENTS[62789] = Fluid3D([4216,3936,3773,4294],0); -ELEMENTS[62790] = Fluid3D([15551,15764,15972,15423],0); -ELEMENTS[62791] = Fluid3D([10638,10043,11286,10527],0); -ELEMENTS[62792] = Fluid3D([11286,10638,10527,10552],0); -ELEMENTS[62793] = Fluid3D([9500,9290,8595,10209],0); -ELEMENTS[62794] = Fluid3D([17988,18052,18247,17877],0); -ELEMENTS[62795] = Fluid3D([8659,8962,9080,9884],0); -ELEMENTS[62796] = Fluid3D([15028,15460,15330,14427],0); -ELEMENTS[62797] = Fluid3D([2276,2469,2509,2649],0); -ELEMENTS[62798] = Fluid3D([15233,14782,15068,14279],0); -ELEMENTS[62799] = Fluid3D([15278,15493,15973,15643],0); -ELEMENTS[62800] = Fluid3D([18676,18657,18682,18660],0); -ELEMENTS[62801] = Fluid3D([18500,18515,18581,18423],0); -ELEMENTS[62802] = Fluid3D([18500,18515,18423,18281],0); -ELEMENTS[62803] = Fluid3D([15901,15451,16080,15543],0); -ELEMENTS[62804] = Fluid3D([16730,16939,17062,16453],0); -ELEMENTS[62805] = Fluid3D([2487,2374,2630,2615],0); -ELEMENTS[62806] = Fluid3D([6444,5895,6500,6656],0); -ELEMENTS[62807] = Fluid3D([6500,6444,6656,7477],0); -ELEMENTS[62808] = Fluid3D([6444,5895,6656,6143],0); -ELEMENTS[62809] = Fluid3D([17708,17631,17335,17799],0); -ELEMENTS[62810] = Fluid3D([16352,16090,15752,16049],0); -ELEMENTS[62811] = Fluid3D([10441,11041,10021,11237],0); -ELEMENTS[62812] = Fluid3D([12095,11754,12266,11158],0); -ELEMENTS[62813] = Fluid3D([16844,16443,16497,16821],0); -ELEMENTS[62814] = Fluid3D([16844,16443,16821,17106],0); -ELEMENTS[62815] = Fluid3D([3867,3708,4015,3561],0); -ELEMENTS[62816] = Fluid3D([6984,7344,7236,8246],0); -ELEMENTS[62817] = Fluid3D([2028,2072,1917,2193],0); -ELEMENTS[62818] = Fluid3D([11362,11170,10284,10889],0); -ELEMENTS[62819] = Fluid3D([18498,18453,18331,18380],0); -ELEMENTS[62820] = Fluid3D([6692,6412,6462,5845],0); -ELEMENTS[62821] = Fluid3D([13891,13845,13995,14943],0); -ELEMENTS[62822] = Fluid3D([18122,18045,18219,18378],0); -ELEMENTS[62823] = Fluid3D([18274,18168,18343,18096],0); -ELEMENTS[62824] = Fluid3D([15967,16165,16353,15666],0); -ELEMENTS[62825] = Fluid3D([2144,2357,2254,2346],0); -ELEMENTS[62826] = Fluid3D([15506,14735,15026,15109],0); -ELEMENTS[62827] = Fluid3D([15698,16083,15448,15239],0); -ELEMENTS[62828] = Fluid3D([6370,7133,6491,6779],0); -ELEMENTS[62829] = Fluid3D([7133,6491,6779,6730],0); -ELEMENTS[62830] = Fluid3D([8078,7249,7529,8347],0); -ELEMENTS[62831] = Fluid3D([18006,18106,17883,17835],0); -ELEMENTS[62832] = Fluid3D([18006,18106,17835,18034],0); -ELEMENTS[62833] = Fluid3D([15925,15236,15411,15549],0); -ELEMENTS[62834] = Fluid3D([16194,15816,15565,16010],0); -ELEMENTS[62835] = Fluid3D([5428,5840,6059,6639],0); -ELEMENTS[62836] = Fluid3D([10871,9861,10227,10308],0); -ELEMENTS[62837] = Fluid3D([3174,3385,3537,3751],0); -ELEMENTS[62838] = Fluid3D([7035,7890,7838,7841],0); -ELEMENTS[62839] = Fluid3D([14197,13678,13977,12936],0); -ELEMENTS[62840] = Fluid3D([5963,5715,5738,5053],0); -ELEMENTS[62841] = Fluid3D([10493,9677,10624,10290],0); -ELEMENTS[62842] = Fluid3D([7595,6763,7315,7598],0); -ELEMENTS[62843] = Fluid3D([6907,7718,7453,7269],0); -ELEMENTS[62844] = Fluid3D([16879,17043,16716,16687],0); -ELEMENTS[62845] = Fluid3D([12148,11587,11161,12044],0); -ELEMENTS[62846] = Fluid3D([14928,15227,15372,14419],0); -ELEMENTS[62847] = Fluid3D([13299,13679,13191,12901],0); -ELEMENTS[62848] = Fluid3D([9540,8631,9314,9966],0); -ELEMENTS[62849] = Fluid3D([5032,5430,4891,5560],0); -ELEMENTS[62850] = Fluid3D([5032,5430,5560,5916],0); -ELEMENTS[62851] = Fluid3D([10712,10953,11779,11002],0); -ELEMENTS[62852] = Fluid3D([13824,13466,13314,12664],0); -ELEMENTS[62853] = Fluid3D([8933,9516,8460,9353],0); -ELEMENTS[62854] = Fluid3D([17567,17675,17914,17462],0); -ELEMENTS[62855] = Fluid3D([16766,17093,16568,16684],0); -ELEMENTS[62856] = Fluid3D([15114,14660,14884,14230],0); -ELEMENTS[62857] = Fluid3D([1740,1677,1785,1870],0); -ELEMENTS[62858] = Fluid3D([3656,3257,3464,3848],0); -ELEMENTS[62859] = Fluid3D([16344,16628,16681,16186],0); -ELEMENTS[62860] = Fluid3D([16701,17042,16569,16690],0); -ELEMENTS[62861] = Fluid3D([16866,17179,16958,16661],0); -ELEMENTS[62862] = Fluid3D([16866,17179,16661,17228],0); -ELEMENTS[62863] = Fluid3D([16866,17179,17228,17338],0); -ELEMENTS[62864] = Fluid3D([16866,17179,17338,17499],0); -ELEMENTS[62865] = Fluid3D([17179,17338,17499,17575],0); -ELEMENTS[62866] = Fluid3D([17179,17228,17338,17575],0); -ELEMENTS[62867] = Fluid3D([17179,17228,17575,17281],0); -ELEMENTS[62868] = Fluid3D([17228,17575,17281,17309],0); -ELEMENTS[62869] = Fluid3D([17179,17228,17281,16661],0); -ELEMENTS[62870] = Fluid3D([17575,17179,17281,17477],0); -ELEMENTS[62871] = Fluid3D([17575,17281,17309,17564],0); -ELEMENTS[62872] = Fluid3D([17575,17281,17564,17477],0); -ELEMENTS[62873] = Fluid3D([10022,9443,9255,9567],0); -ELEMENTS[62874] = Fluid3D([14473,14295,14782,13946],0); -ELEMENTS[62875] = Fluid3D([14473,14295,13946,13602],0); -ELEMENTS[62876] = Fluid3D([13946,14473,13602,14279],0); -ELEMENTS[62877] = Fluid3D([13602,13946,14279,13383],0); -ELEMENTS[62878] = Fluid3D([13602,13946,13383,14295],0); -ELEMENTS[62879] = Fluid3D([13946,14279,13383,13866],0); -ELEMENTS[62880] = Fluid3D([13383,13946,13866,14295],0); -ELEMENTS[62881] = Fluid3D([13946,14473,14279,14782],0); -ELEMENTS[62882] = Fluid3D([14279,13946,14782,13866],0); -ELEMENTS[62883] = Fluid3D([14295,14782,13946,13866],0); -ELEMENTS[62884] = Fluid3D([15521,15777,15361,14941],0); -ELEMENTS[62885] = Fluid3D([12181,12079,12157,11246],0); -ELEMENTS[62886] = Fluid3D([8913,8259,8575,9648],0); -ELEMENTS[62887] = Fluid3D([11420,11069,10314,11249],0); -ELEMENTS[62888] = Fluid3D([18265,18115,18286,18135],0); -ELEMENTS[62889] = Fluid3D([14519,14765,15265,14580],0); -ELEMENTS[62890] = Fluid3D([17799,17805,17560,17789],0); -ELEMENTS[62891] = Fluid3D([8630,8403,7765,7587],0); -ELEMENTS[62892] = Fluid3D([6121,5527,6015,6331],0); -ELEMENTS[62893] = Fluid3D([3660,3224,3544,3204],0); -ELEMENTS[62894] = Fluid3D([4876,5439,5153,5650],0); -ELEMENTS[62895] = Fluid3D([7072,7958,7890,7602],0); -ELEMENTS[62896] = Fluid3D([14323,14124,13838,13116],0); -ELEMENTS[62897] = Fluid3D([12604,12399,11684,11619],0); -ELEMENTS[62898] = Fluid3D([10958,11670,10700,11504],0); -ELEMENTS[62899] = Fluid3D([10958,11670,11504,12069],0); -ELEMENTS[62900] = Fluid3D([10700,10958,11504,10495],0); -ELEMENTS[62901] = Fluid3D([11504,10700,10495,11299],0); -ELEMENTS[62902] = Fluid3D([10495,11504,11299,10956],0); -ELEMENTS[62903] = Fluid3D([11670,10700,11504,12368],0); -ELEMENTS[62904] = Fluid3D([11504,11670,12368,12069],0); -ELEMENTS[62905] = Fluid3D([12368,11504,12069,11898],0); -ELEMENTS[62906] = Fluid3D([12368,11504,11898,10700],0); -ELEMENTS[62907] = Fluid3D([12069,12368,11898,12206],0); -ELEMENTS[62908] = Fluid3D([12368,11898,12206,13099],0); -ELEMENTS[62909] = Fluid3D([12069,12368,12206,12839],0); -ELEMENTS[62910] = Fluid3D([12206,12069,12839,12676],0); -ELEMENTS[62911] = Fluid3D([12069,12368,12839,13312],0); -ELEMENTS[62912] = Fluid3D([12368,12206,12839,13099],0); -ELEMENTS[62913] = Fluid3D([12069,12839,12676,13312],0); -ELEMENTS[62914] = Fluid3D([12368,12839,13312,13099],0); -ELEMENTS[62915] = Fluid3D([11504,12069,11898,11299],0); -ELEMENTS[62916] = Fluid3D([11504,12069,11299,10956],0); -ELEMENTS[62917] = Fluid3D([11898,11504,11299,10700],0); -ELEMENTS[62918] = Fluid3D([11504,12069,10956,10958],0); -ELEMENTS[62919] = Fluid3D([12839,12206,12676,12404],0); -ELEMENTS[62920] = Fluid3D([12839,12206,12404,13618],0); -ELEMENTS[62921] = Fluid3D([2132,2072,2264,2350],0); -ELEMENTS[62922] = Fluid3D([13104,13601,13202,12416],0); -ELEMENTS[62923] = Fluid3D([11798,12175,12847,12101],0); -ELEMENTS[62924] = Fluid3D([12847,11798,12101,12492],0); -ELEMENTS[62925] = Fluid3D([13048,13762,13281,13252],0); -ELEMENTS[62926] = Fluid3D([14813,15280,15029,14329],0); -ELEMENTS[62927] = Fluid3D([2498,2611,2784,2948],0); -ELEMENTS[62928] = Fluid3D([9900,9814,9026,8995],0); -ELEMENTS[62929] = Fluid3D([2043,2144,1978,2106],0); -ELEMENTS[62930] = Fluid3D([7559,7883,8492,8795],0); -ELEMENTS[62931] = Fluid3D([5221,4781,5334,4754],0); -ELEMENTS[62932] = Fluid3D([14729,14980,15493,15307],0); -ELEMENTS[62933] = Fluid3D([18505,18536,18589,18374],0); -ELEMENTS[62934] = Fluid3D([13958,14331,14862,14435],0); -ELEMENTS[62935] = Fluid3D([14862,13958,14435,14562],0); -ELEMENTS[62936] = Fluid3D([14435,14862,14562,15118],0); -ELEMENTS[62937] = Fluid3D([14435,14862,15118,14331],0); -ELEMENTS[62938] = Fluid3D([14562,14435,15118,15433],0); -ELEMENTS[62939] = Fluid3D([13958,14331,14435,13665],0); -ELEMENTS[62940] = Fluid3D([14435,13958,13665,13817],0); -ELEMENTS[62941] = Fluid3D([2777,3024,2738,3018],0); -ELEMENTS[62942] = Fluid3D([15583,15356,15149,14929],0); -ELEMENTS[62943] = Fluid3D([15708,15469,15280,14935],0); -ELEMENTS[62944] = Fluid3D([2863,2932,2721,2672],0); -ELEMENTS[62945] = Fluid3D([2721,2863,2672,2529],0); -ELEMENTS[62946] = Fluid3D([2863,2932,2672,2720],0); -ELEMENTS[62947] = Fluid3D([2672,2863,2720,2529],0); -ELEMENTS[62948] = Fluid3D([2932,2721,2672,2480],0); -ELEMENTS[62949] = Fluid3D([2721,2672,2480,2273],0); -ELEMENTS[62950] = Fluid3D([2863,2932,2720,2912],0); -ELEMENTS[62951] = Fluid3D([2720,2863,2912,3164],0); -ELEMENTS[62952] = Fluid3D([2720,2863,3164,2692],0); -ELEMENTS[62953] = Fluid3D([2720,2863,2692,2529],0); -ELEMENTS[62954] = Fluid3D([4571,4284,4796,4804],0); -ELEMENTS[62955] = Fluid3D([17559,17723,17459,17183],0); -ELEMENTS[62956] = Fluid3D([3018,2957,2738,2777],0); -ELEMENTS[62957] = Fluid3D([12164,12883,12423,11969],0); -ELEMENTS[62958] = Fluid3D([13520,12590,12970,13574],0); -ELEMENTS[62959] = Fluid3D([12712,13275,13615,13732],0); -ELEMENTS[62960] = Fluid3D([9244,9105,8288,9201],0); -ELEMENTS[62961] = Fluid3D([14418,13918,14124,13780],0); -ELEMENTS[62962] = Fluid3D([3517,3559,3355,3180],0); -ELEMENTS[62963] = Fluid3D([3517,3559,3180,3661],0); -ELEMENTS[62964] = Fluid3D([3716,4147,4031,4207],0); -ELEMENTS[62965] = Fluid3D([8847,9637,8627,9247],0); -ELEMENTS[62966] = Fluid3D([10535,11468,10661,10669],0); -ELEMENTS[62967] = Fluid3D([10661,10535,10669,9836],0); -ELEMENTS[62968] = Fluid3D([18494,18369,18404,18222],0); -ELEMENTS[62969] = Fluid3D([16353,16153,15967,15642],0); -ELEMENTS[62970] = Fluid3D([5538,4953,5287,5677],0); -ELEMENTS[62971] = Fluid3D([3082,2905,3022,2770],0); -ELEMENTS[62972] = Fluid3D([3082,2905,2770,2943],0); -ELEMENTS[62973] = Fluid3D([2905,3022,2770,2718],0); -ELEMENTS[62974] = Fluid3D([12197,11270,11472,11031],0); -ELEMENTS[62975] = Fluid3D([16344,16681,16398,16186],0); -ELEMENTS[62976] = Fluid3D([3409,3193,3593,3527],0); -ELEMENTS[62977] = Fluid3D([18589,18562,18505,18374],0); -ELEMENTS[62978] = Fluid3D([8583,8293,7718,7269],0); -ELEMENTS[62979] = Fluid3D([10581,10144,11161,11307],0); -ELEMENTS[62980] = Fluid3D([17685,17551,17246,17630],0); -ELEMENTS[62981] = Fluid3D([2781,3020,3084,3239],0); -ELEMENTS[62982] = Fluid3D([16277,16550,16296,15915],0); -ELEMENTS[62983] = Fluid3D([7210,6676,6083,6224],0); -ELEMENTS[62984] = Fluid3D([18577,18619,18545,18547],0); -ELEMENTS[62985] = Fluid3D([10321,11091,11397,9882],0); -ELEMENTS[62986] = Fluid3D([17642,17630,17392,17048],0); -ELEMENTS[62987] = Fluid3D([18501,18561,18586,18631],0); -ELEMENTS[62988] = Fluid3D([17418,17111,17302,16963],0); -ELEMENTS[62989] = Fluid3D([17579,17440,17299,17040],0); -ELEMENTS[62990] = Fluid3D([6500,5895,5948,6656],0); -ELEMENTS[62991] = Fluid3D([4276,4763,4395,4629],0); -ELEMENTS[62992] = Fluid3D([12506,11969,11786,11835],0); -ELEMENTS[62993] = Fluid3D([18424,18446,18531,18298],0); -ELEMENTS[62994] = Fluid3D([3835,3435,3752,3911],0); -ELEMENTS[62995] = Fluid3D([8468,9058,9386,9308],0); -ELEMENTS[62996] = Fluid3D([17632,17508,17771,17389],0); -ELEMENTS[62997] = Fluid3D([2320,2368,2160,2425],0); -ELEMENTS[62998] = Fluid3D([15962,15246,15506,15485],0); -ELEMENTS[62999] = Fluid3D([13132,13650,13425,12601],0); -ELEMENTS[63000] = Fluid3D([2224,2279,2132,2022],0); -ELEMENTS[63001] = Fluid3D([4870,4701,4610,4221],0); -ELEMENTS[63002] = Fluid3D([4138,3830,4172,4100],0); -ELEMENTS[63003] = Fluid3D([16365,15840,15944,15936],0); -ELEMENTS[63004] = Fluid3D([15944,16365,15936,16368],0); -ELEMENTS[63005] = Fluid3D([13118,13051,14023,13554],0); -ELEMENTS[63006] = Fluid3D([9359,9924,9330,9175],0); -ELEMENTS[63007] = Fluid3D([10036,9538,9692,9645],0); -ELEMENTS[63008] = Fluid3D([15626,16074,15630,15041],0); -ELEMENTS[63009] = Fluid3D([13915,13787,13747,14657],0); -ELEMENTS[63010] = Fluid3D([8102,7272,8174,7326],0); -ELEMENTS[63011] = Fluid3D([9003,9889,9748,9660],0); -ELEMENTS[63012] = Fluid3D([17704,17720,17333,17317],0); -ELEMENTS[63013] = Fluid3D([18024,18098,18287,18130],0); -ELEMENTS[63014] = Fluid3D([18610,18534,18626,18574],0); -ELEMENTS[63015] = Fluid3D([14821,14872,15524,15340],0); -ELEMENTS[63016] = Fluid3D([8334,8439,7778,9090],0); -ELEMENTS[63017] = Fluid3D([12507,11774,12554,12088],0); -ELEMENTS[63018] = Fluid3D([9517,9809,8649,8819],0); -ELEMENTS[63019] = Fluid3D([7283,6679,6900,7644],0); -ELEMENTS[63020] = Fluid3D([11211,12097,11293,11451],0); -ELEMENTS[63021] = Fluid3D([11211,12097,11451,11300],0); -ELEMENTS[63022] = Fluid3D([3783,3808,3381,3692],0); -ELEMENTS[63023] = Fluid3D([16531,16156,16411,15758],0); -ELEMENTS[63024] = Fluid3D([13275,13615,13732,14522],0); -ELEMENTS[63025] = Fluid3D([13921,13546,12993,13844],0); -ELEMENTS[63026] = Fluid3D([11798,12101,12492,11855],0); -ELEMENTS[63027] = Fluid3D([7036,6655,7676,7396],0); -ELEMENTS[63028] = Fluid3D([7191,7422,8025,7453],0); -ELEMENTS[63029] = Fluid3D([5583,5674,6134,5335],0); -ELEMENTS[63030] = Fluid3D([5583,5674,5335,4731],0); -ELEMENTS[63031] = Fluid3D([4711,4068,4243,4407],0); -ELEMENTS[63032] = Fluid3D([4068,4243,4407,4103],0); -ELEMENTS[63033] = Fluid3D([4429,4422,5035,4797],0); -ELEMENTS[63034] = Fluid3D([4429,4422,4797,4295],0); -ELEMENTS[63035] = Fluid3D([5035,4429,4797,4679],0); -ELEMENTS[63036] = Fluid3D([6148,5537,5532,6130],0); -ELEMENTS[63037] = Fluid3D([5537,5532,6130,5763],0); -ELEMENTS[63038] = Fluid3D([5532,6130,5763,5485],0); -ELEMENTS[63039] = Fluid3D([6130,5763,5485,5821],0); -ELEMENTS[63040] = Fluid3D([6130,5763,5821,5544],0); -ELEMENTS[63041] = Fluid3D([6130,5763,5544,5537],0); -ELEMENTS[63042] = Fluid3D([5763,5821,5544,5485],0); -ELEMENTS[63043] = Fluid3D([5763,5544,5537,5485],0); -ELEMENTS[63044] = Fluid3D([5544,6130,5537,6148],0); -ELEMENTS[63045] = Fluid3D([5537,5544,6148,5711],0); -ELEMENTS[63046] = Fluid3D([5537,5532,5763,5485],0); -ELEMENTS[63047] = Fluid3D([5537,5544,5711,5369],0); -ELEMENTS[63048] = Fluid3D([5544,6130,6148,5821],0); -ELEMENTS[63049] = Fluid3D([5544,6148,5711,5821],0); -ELEMENTS[63050] = Fluid3D([7589,7147,8202,8035],0); -ELEMENTS[63051] = Fluid3D([14650,14372,15149,14929],0); -ELEMENTS[63052] = Fluid3D([5659,5589,5077,4813],0); -ELEMENTS[63053] = Fluid3D([2518,2516,2507,2211],0); -ELEMENTS[63054] = Fluid3D([14974,14170,14193,14630],0); -ELEMENTS[63055] = Fluid3D([2833,2876,3234,3062],0); -ELEMENTS[63056] = Fluid3D([6098,6388,6438,7193],0); -ELEMENTS[63057] = Fluid3D([6388,6438,7193,7024],0); -ELEMENTS[63058] = Fluid3D([5634,5738,5192,5979],0); -ELEMENTS[63059] = Fluid3D([17846,17621,17829,17647],0); -ELEMENTS[63060] = Fluid3D([17621,17829,17647,17445],0); -ELEMENTS[63061] = Fluid3D([17829,17846,17647,18032],0); -ELEMENTS[63062] = Fluid3D([17647,17829,18032,17667],0); -ELEMENTS[63063] = Fluid3D([17647,17829,17667,17684],0); -ELEMENTS[63064] = Fluid3D([17829,17667,17684,17927],0); -ELEMENTS[63065] = Fluid3D([17829,17667,17927,18032],0); -ELEMENTS[63066] = Fluid3D([17667,17684,17927,17298],0); -ELEMENTS[63067] = Fluid3D([17667,17684,17298,17647],0); -ELEMENTS[63068] = Fluid3D([17829,17647,17445,17684],0); -ELEMENTS[63069] = Fluid3D([17445,17829,17684,17621],0); -ELEMENTS[63070] = Fluid3D([12409,12779,13399,12149],0); -ELEMENTS[63071] = Fluid3D([18688,18691,18695,18696],0); -ELEMENTS[63072] = Fluid3D([10114,10466,10472,9616],0); -ELEMENTS[63073] = Fluid3D([10466,10472,9616,10551],0); -ELEMENTS[63074] = Fluid3D([10466,10472,10551,11567],0); -ELEMENTS[63075] = Fluid3D([10472,9616,10551,9963],0); -ELEMENTS[63076] = Fluid3D([10551,10472,9963,10757],0); -ELEMENTS[63077] = Fluid3D([10551,10466,11567,11174],0); -ELEMENTS[63078] = Fluid3D([11567,10551,11174,11229],0); -ELEMENTS[63079] = Fluid3D([11174,11567,11229,11604],0); -ELEMENTS[63080] = Fluid3D([11229,11174,11604,10089],0); -ELEMENTS[63081] = Fluid3D([11174,11567,11604,11429],0); -ELEMENTS[63082] = Fluid3D([11174,11567,11429,10466],0); -ELEMENTS[63083] = Fluid3D([8440,8043,7690,8669],0); -ELEMENTS[63084] = Fluid3D([14343,14576,14161,14720],0); -ELEMENTS[63085] = Fluid3D([14343,14576,14720,15375],0); -ELEMENTS[63086] = Fluid3D([9174,9961,9126,9944],0); -ELEMENTS[63087] = Fluid3D([9126,9174,9944,9665],0); -ELEMENTS[63088] = Fluid3D([8098,9024,9102,8194],0); -ELEMENTS[63089] = Fluid3D([12278,13200,12734,12700],0); -ELEMENTS[63090] = Fluid3D([15525,15369,15708,15932],0); -ELEMENTS[63091] = Fluid3D([14835,14867,14255,14799],0); -ELEMENTS[63092] = Fluid3D([2319,2496,2340,2555],0); -ELEMENTS[63093] = Fluid3D([2340,2319,2555,2250],0); -ELEMENTS[63094] = Fluid3D([2319,2496,2555,2598],0); -ELEMENTS[63095] = Fluid3D([12110,12167,12816,13309],0); -ELEMENTS[63096] = Fluid3D([4212,4542,4494,3805],0); -ELEMENTS[63097] = Fluid3D([10293,10833,10336,11520],0); -ELEMENTS[63098] = Fluid3D([17358,17282,17056,17164],0); -ELEMENTS[63099] = Fluid3D([11307,12044,12012,11503],0); -ELEMENTS[63100] = Fluid3D([11307,12044,11503,11161],0); -ELEMENTS[63101] = Fluid3D([12044,11503,11161,11675],0); -ELEMENTS[63102] = Fluid3D([11503,11307,11161,10144],0); -ELEMENTS[63103] = Fluid3D([11161,11503,10144,10770],0); -ELEMENTS[63104] = Fluid3D([11161,11503,10770,10756],0); -ELEMENTS[63105] = Fluid3D([11161,11503,10756,11675],0); -ELEMENTS[63106] = Fluid3D([11503,10770,10756,11675],0); -ELEMENTS[63107] = Fluid3D([11503,10770,11675,12012],0); -ELEMENTS[63108] = Fluid3D([11503,10144,10770,11307],0); -ELEMENTS[63109] = Fluid3D([10770,10756,11675,10371],0); -ELEMENTS[63110] = Fluid3D([10770,11503,11307,12012],0); -ELEMENTS[63111] = Fluid3D([12044,12012,11503,11675],0); -ELEMENTS[63112] = Fluid3D([13528,14023,13118,13390],0); -ELEMENTS[63113] = Fluid3D([3277,3047,3470,3563],0); -ELEMENTS[63114] = Fluid3D([4072,3681,3851,4109],0); -ELEMENTS[63115] = Fluid3D([3608,3433,3570,4118],0); -ELEMENTS[63116] = Fluid3D([2532,2673,2365,2272],0); -ELEMENTS[63117] = Fluid3D([2532,2673,2272,2598],0); -ELEMENTS[63118] = Fluid3D([2532,2673,2598,2910],0); -ELEMENTS[63119] = Fluid3D([7320,6789,6676,6571],0); -ELEMENTS[63120] = Fluid3D([11957,11446,12025,12439],0); -ELEMENTS[63121] = Fluid3D([16111,15859,16291,15525],0); -ELEMENTS[63122] = Fluid3D([16111,15859,15525,15369],0); -ELEMENTS[63123] = Fluid3D([14856,15162,15236,14433],0); -ELEMENTS[63124] = Fluid3D([13508,13222,12688,12672],0); -ELEMENTS[63125] = Fluid3D([13222,12688,12672,12531],0); -ELEMENTS[63126] = Fluid3D([13222,12688,12531,12149],0); -ELEMENTS[63127] = Fluid3D([12688,13508,12672,13746],0); -ELEMENTS[63128] = Fluid3D([15590,15577,15892,14839],0); -ELEMENTS[63129] = Fluid3D([5309,5636,5794,5139],0); -ELEMENTS[63130] = Fluid3D([15399,15836,15175,15244],0); -ELEMENTS[63131] = Fluid3D([15175,15399,15244,14321],0); -ELEMENTS[63132] = Fluid3D([12793,12178,12805,13158],0); -ELEMENTS[63133] = Fluid3D([9377,8430,8471,9179],0); -ELEMENTS[63134] = Fluid3D([10746,11623,11546,10384],0); -ELEMENTS[63135] = Fluid3D([13137,12290,12994,12255],0); -ELEMENTS[63136] = Fluid3D([2550,2743,2701,2804],0); -ELEMENTS[63137] = Fluid3D([5401,5752,5202,5971],0); -ELEMENTS[63138] = Fluid3D([16793,16751,16923,16396],0); -ELEMENTS[63139] = Fluid3D([18415,18437,18546,18426],0); -ELEMENTS[63140] = Fluid3D([17306,17640,17320,17123],0); -ELEMENTS[63141] = Fluid3D([17320,17306,17123,16750],0); -ELEMENTS[63142] = Fluid3D([16965,16989,17371,17062],0); -ELEMENTS[63143] = Fluid3D([18382,18345,18505,18374],0); -ELEMENTS[63144] = Fluid3D([18345,18505,18374,18536],0); -ELEMENTS[63145] = Fluid3D([17956,18192,18301,18034],0); -ELEMENTS[63146] = Fluid3D([7672,8789,8593,8029],0); -ELEMENTS[63147] = Fluid3D([4202,3940,4295,3661],0); -ELEMENTS[63148] = Fluid3D([14111,13986,14068,13270],0); -ELEMENTS[63149] = Fluid3D([14180,14546,14962,14049],0); -ELEMENTS[63150] = Fluid3D([8926,9818,9697,8743],0); -ELEMENTS[63151] = Fluid3D([4267,3945,3612,3717],0); -ELEMENTS[63152] = Fluid3D([7297,8164,7706,7820],0); -ELEMENTS[63153] = Fluid3D([7121,7856,7932,7919],0); -ELEMENTS[63154] = Fluid3D([12632,12024,11731,12710],0); -ELEMENTS[63155] = Fluid3D([14602,14256,14488,14923],0); -ELEMENTS[63156] = Fluid3D([13322,13815,13136,12907],0); -ELEMENTS[63157] = Fluid3D([13386,12975,12845,13197],0); -ELEMENTS[63158] = Fluid3D([13386,12975,13197,14054],0); -ELEMENTS[63159] = Fluid3D([10846,9839,11019,10870],0); -ELEMENTS[63160] = Fluid3D([15667,15780,15358,14882],0); -ELEMENTS[63161] = Fluid3D([15220,14698,15324,14706],0); -ELEMENTS[63162] = Fluid3D([15987,16071,16455,16033],0); -ELEMENTS[63163] = Fluid3D([16071,16455,16033,16762],0); -ELEMENTS[63164] = Fluid3D([5368,4924,5097,5506],0); -ELEMENTS[63165] = Fluid3D([14538,14253,15298,14892],0); -ELEMENTS[63166] = Fluid3D([4740,5251,4536,4879],0); -ELEMENTS[63167] = Fluid3D([11215,10282,10964,10408],0); -ELEMENTS[63168] = Fluid3D([6147,6365,5794,5945],0); -ELEMENTS[63169] = Fluid3D([14168,13604,13553,13336],0); -ELEMENTS[63170] = Fluid3D([5523,4963,5804,5278],0); -ELEMENTS[63171] = Fluid3D([16253,16342,16449,16915],0); -ELEMENTS[63172] = Fluid3D([11570,11057,11823,10372],0); -ELEMENTS[63173] = Fluid3D([15383,15173,15439,14785],0); -ELEMENTS[63174] = Fluid3D([15383,15173,14785,14627],0); -ELEMENTS[63175] = Fluid3D([15173,15439,14785,14883],0); -ELEMENTS[63176] = Fluid3D([14785,15173,14883,15012],0); -ELEMENTS[63177] = Fluid3D([15173,14883,15012,15743],0); -ELEMENTS[63178] = Fluid3D([14785,15173,15012,14627],0); -ELEMENTS[63179] = Fluid3D([15173,14883,15743,15439],0); -ELEMENTS[63180] = Fluid3D([10061,10514,11422,11287],0); -ELEMENTS[63181] = Fluid3D([9657,9485,10639,10387],0); -ELEMENTS[63182] = Fluid3D([9657,9485,10387,10515],0); -ELEMENTS[63183] = Fluid3D([15863,15542,15118,15621],0); -ELEMENTS[63184] = Fluid3D([9661,8773,9491,9387],0); -ELEMENTS[63185] = Fluid3D([3337,3583,3638,3985],0); -ELEMENTS[63186] = Fluid3D([18452,18420,18555,18517],0); -ELEMENTS[63187] = Fluid3D([11185,11326,10459,10606],0); -ELEMENTS[63188] = Fluid3D([11583,12273,11996,12652],0); -ELEMENTS[63189] = Fluid3D([4617,5136,4403,4946],0); -ELEMENTS[63190] = Fluid3D([16181,16027,15755,15891],0); -ELEMENTS[63191] = Fluid3D([7497,7249,6992,8097],0); -ELEMENTS[63192] = Fluid3D([3056,3344,3000,2789],0); -ELEMENTS[63193] = Fluid3D([8630,8484,9547,8213],0); -ELEMENTS[63194] = Fluid3D([8630,8484,8213,7422],0); -ELEMENTS[63195] = Fluid3D([16752,17135,17108,17088],0); -ELEMENTS[63196] = Fluid3D([16752,17135,17088,16678],0); -ELEMENTS[63197] = Fluid3D([17135,17088,16678,17167],0); -ELEMENTS[63198] = Fluid3D([17135,17108,17088,17550],0); -ELEMENTS[63199] = Fluid3D([5727,5527,4980,5335],0); -ELEMENTS[63200] = Fluid3D([3783,4070,4268,3692],0); -ELEMENTS[63201] = Fluid3D([6642,7458,6428,7135],0); -ELEMENTS[63202] = Fluid3D([9477,9665,8815,8686],0); -ELEMENTS[63203] = Fluid3D([17760,17969,18126,18073],0); -ELEMENTS[63204] = Fluid3D([9145,9221,9514,9847],0); -ELEMENTS[63205] = Fluid3D([9145,9221,9847,8871],0); -ELEMENTS[63206] = Fluid3D([9221,9514,9847,9951],0); -ELEMENTS[63207] = Fluid3D([9847,9221,9951,9827],0); -ELEMENTS[63208] = Fluid3D([9221,9514,9951,9745],0); -ELEMENTS[63209] = Fluid3D([9951,9221,9745,9827],0); -ELEMENTS[63210] = Fluid3D([9745,9951,9827,10900],0); -ELEMENTS[63211] = Fluid3D([9951,9827,10900,9847],0); -ELEMENTS[63212] = Fluid3D([9745,9951,10900,10595],0); -ELEMENTS[63213] = Fluid3D([9951,10900,10595,9847],0); -ELEMENTS[63214] = Fluid3D([9745,9951,10595,9514],0); -ELEMENTS[63215] = Fluid3D([9951,10595,9514,9847],0); -ELEMENTS[63216] = Fluid3D([9221,9847,8871,9827],0); -ELEMENTS[63217] = Fluid3D([17935,17756,18089,17918],0); -ELEMENTS[63218] = Fluid3D([15943,15882,15579,16363],0); -ELEMENTS[63219] = Fluid3D([9106,9446,9209,9030],0); -ELEMENTS[63220] = Fluid3D([9106,9446,9030,8180],0); -ELEMENTS[63221] = Fluid3D([6336,6152,5974,7090],0); -ELEMENTS[63222] = Fluid3D([13645,13075,13872,13575],0); -ELEMENTS[63223] = Fluid3D([6986,7120,6890,7929],0); -ELEMENTS[63224] = Fluid3D([6986,7120,7929,7723],0); -ELEMENTS[63225] = Fluid3D([3090,3235,3259,3658],0); -ELEMENTS[63226] = Fluid3D([14142,13842,13667,14802],0); -ELEMENTS[63227] = Fluid3D([16638,16595,16331,16712],0); -ELEMENTS[63228] = Fluid3D([16638,16595,16712,17224],0); -ELEMENTS[63229] = Fluid3D([4654,4522,5103,4726],0); -ELEMENTS[63230] = Fluid3D([5103,4654,4726,5174],0); -ELEMENTS[63231] = Fluid3D([4654,4726,5174,4574],0); -ELEMENTS[63232] = Fluid3D([4654,4726,4574,4156],0); -ELEMENTS[63233] = Fluid3D([4654,4726,4156,4522],0); -ELEMENTS[63234] = Fluid3D([4726,4574,4156,4280],0); -ELEMENTS[63235] = Fluid3D([4574,4156,4280,4294],0); -ELEMENTS[63236] = Fluid3D([4280,4574,4294,4893],0); -ELEMENTS[63237] = Fluid3D([4280,4574,4893,4769],0); -ELEMENTS[63238] = Fluid3D([4280,4574,4769,4726],0); -ELEMENTS[63239] = Fluid3D([4574,4893,4769,5564],0); -ELEMENTS[63240] = Fluid3D([4726,5174,4574,4769],0); -ELEMENTS[63241] = Fluid3D([4574,4294,4893,4654],0); -ELEMENTS[63242] = Fluid3D([4574,4294,4654,4156],0); -ELEMENTS[63243] = Fluid3D([5174,4574,4769,5564],0); -ELEMENTS[63244] = Fluid3D([12962,12769,12696,12112],0); -ELEMENTS[63245] = Fluid3D([9170,8385,9108,8979],0); -ELEMENTS[63246] = Fluid3D([17737,17920,17692,17746],0); -ELEMENTS[63247] = Fluid3D([9692,9325,10188,9161],0); -ELEMENTS[63248] = Fluid3D([7317,7795,7819,7014],0); -ELEMENTS[63249] = Fluid3D([12330,11962,12222,11046],0); -ELEMENTS[63250] = Fluid3D([2652,2455,2733,2451],0); -ELEMENTS[63251] = Fluid3D([15531,16063,16054,15562],0); -ELEMENTS[63252] = Fluid3D([16054,15531,15562,15513],0); -ELEMENTS[63253] = Fluid3D([17062,16730,16453,16710],0); -ELEMENTS[63254] = Fluid3D([4209,3950,4150,4669],0); -ELEMENTS[63255] = Fluid3D([15357,14997,15701,16025],0); -ELEMENTS[63256] = Fluid3D([2287,2270,2065,2213],0); -ELEMENTS[63257] = Fluid3D([17294,17699,17415,17758],0); -ELEMENTS[63258] = Fluid3D([3092,3317,3257,3120],0); -ELEMENTS[63259] = Fluid3D([10765,10264,11061,10146],0); -ELEMENTS[63260] = Fluid3D([14749,14141,14469,13691],0); -ELEMENTS[63261] = Fluid3D([12023,12063,11004,11342],0); -ELEMENTS[63262] = Fluid3D([12023,12063,11342,11663],0); -ELEMENTS[63263] = Fluid3D([11342,12023,11663,10815],0); -ELEMENTS[63264] = Fluid3D([11663,11342,10815,11209],0); -ELEMENTS[63265] = Fluid3D([11663,11342,11209,12063],0); -ELEMENTS[63266] = Fluid3D([11342,12023,10815,11004],0); -ELEMENTS[63267] = Fluid3D([10815,11342,11004,10864],0); -ELEMENTS[63268] = Fluid3D([11342,10815,11209,10864],0); -ELEMENTS[63269] = Fluid3D([11209,11342,10864,12063],0); -ELEMENTS[63270] = Fluid3D([11342,11004,10864,12063],0); -ELEMENTS[63271] = Fluid3D([11087,10544,10287,10344],0); -ELEMENTS[63272] = Fluid3D([10965,11657,11921,11603],0); -ELEMENTS[63273] = Fluid3D([10965,11657,11603,11009],0); -ELEMENTS[63274] = Fluid3D([4319,3926,3680,4237],0); -ELEMENTS[63275] = Fluid3D([18587,18493,18574,18620],0); -ELEMENTS[63276] = Fluid3D([9904,9105,9244,9201],0); -ELEMENTS[63277] = Fluid3D([15860,15873,16127,16480],0); -ELEMENTS[63278] = Fluid3D([6039,6797,6163,5842],0); -ELEMENTS[63279] = Fluid3D([14611,15327,15125,15192],0); -ELEMENTS[63280] = Fluid3D([15913,15555,15603,16277],0); -ELEMENTS[63281] = Fluid3D([9038,9395,8292,9230],0); -ELEMENTS[63282] = Fluid3D([6237,6133,5578,5812],0); -ELEMENTS[63283] = Fluid3D([6237,6133,5812,6803],0); -ELEMENTS[63284] = Fluid3D([5166,5138,5622,5853],0); -ELEMENTS[63285] = Fluid3D([13735,13330,12974,13710],0); -ELEMENTS[63286] = Fluid3D([6527,6183,5704,6516],0); -ELEMENTS[63287] = Fluid3D([6527,6183,6516,6901],0); -ELEMENTS[63288] = Fluid3D([17216,17449,17623,17241],0); -ELEMENTS[63289] = Fluid3D([17216,17449,17241,17412],0); -ELEMENTS[63290] = Fluid3D([17216,17449,17412,17814],0); -ELEMENTS[63291] = Fluid3D([17449,17241,17412,17502],0); -ELEMENTS[63292] = Fluid3D([17449,17623,17241,17695],0); -ELEMENTS[63293] = Fluid3D([17241,17449,17695,17502],0); -ELEMENTS[63294] = Fluid3D([14513,13809,14268,13715],0); -ELEMENTS[63295] = Fluid3D([14268,14513,13715,14823],0); -ELEMENTS[63296] = Fluid3D([13809,14268,13715,13232],0); -ELEMENTS[63297] = Fluid3D([13715,14268,14823,14620],0); -ELEMENTS[63298] = Fluid3D([13715,14268,14620,13780],0); -ELEMENTS[63299] = Fluid3D([4311,4464,4899,4501],0); -ELEMENTS[63300] = Fluid3D([4311,4464,4501,4302],0); -ELEMENTS[63301] = Fluid3D([4899,4311,4501,4385],0); -ELEMENTS[63302] = Fluid3D([4311,4501,4385,4302],0); -ELEMENTS[63303] = Fluid3D([4501,4385,4302,5005],0); -ELEMENTS[63304] = Fluid3D([4302,4501,5005,4889],0); -ELEMENTS[63305] = Fluid3D([4501,5005,4889,4464],0); -ELEMENTS[63306] = Fluid3D([7057,6611,7056,7820],0); -ELEMENTS[63307] = Fluid3D([16891,16530,17164,16780],0); -ELEMENTS[63308] = Fluid3D([4133,3763,3589,4352],0); -ELEMENTS[63309] = Fluid3D([16739,16240,16619,16950],0); -ELEMENTS[63310] = Fluid3D([6898,6278,6301,6184],0); -ELEMENTS[63311] = Fluid3D([10330,10548,11390,11647],0); -ELEMENTS[63312] = Fluid3D([17445,17286,17647,17621],0); -ELEMENTS[63313] = Fluid3D([17445,17286,17621,17366],0); -ELEMENTS[63314] = Fluid3D([17621,17445,17366,17684],0); -ELEMENTS[63315] = Fluid3D([2890,2640,2469,2729],0); -ELEMENTS[63316] = Fluid3D([12670,12248,12262,13407],0); -ELEMENTS[63317] = Fluid3D([9542,10193,9313,8874],0); -ELEMENTS[63318] = Fluid3D([4730,5305,5219,5423],0); -ELEMENTS[63319] = Fluid3D([2298,2141,2223,2485],0); -ELEMENTS[63320] = Fluid3D([2258,2438,2143,2294],0); -ELEMENTS[63321] = Fluid3D([18503,18544,18585,18451],0); -ELEMENTS[63322] = Fluid3D([18503,18544,18451,18441],0); -ELEMENTS[63323] = Fluid3D([14743,14234,14274,13748],0); -ELEMENTS[63324] = Fluid3D([14711,15475,15038,15105],0); -ELEMENTS[63325] = Fluid3D([9185,9117,8289,8650],0); -ELEMENTS[63326] = Fluid3D([15639,15046,15139,15557],0); -ELEMENTS[63327] = Fluid3D([8438,8898,9202,8507],0); -ELEMENTS[63328] = Fluid3D([18249,18445,18449,18229],0); -ELEMENTS[63329] = Fluid3D([18445,18449,18229,18341],0); -ELEMENTS[63330] = Fluid3D([18249,18445,18229,18220],0); -ELEMENTS[63331] = Fluid3D([18449,18229,18341,18318],0); -ELEMENTS[63332] = Fluid3D([18445,18229,18220,18467],0); -ELEMENTS[63333] = Fluid3D([16965,17256,16810,17172],0); -ELEMENTS[63334] = Fluid3D([6448,5854,5929,5953],0); -ELEMENTS[63335] = Fluid3D([5854,5929,5953,5323],0); -ELEMENTS[63336] = Fluid3D([5953,5854,5323,5864],0); -ELEMENTS[63337] = Fluid3D([5953,5854,5864,6568],0); -ELEMENTS[63338] = Fluid3D([5953,5854,6568,6448],0); -ELEMENTS[63339] = Fluid3D([5854,6568,6448,5864],0); -ELEMENTS[63340] = Fluid3D([6568,5953,6448,5929],0); -ELEMENTS[63341] = Fluid3D([6568,5953,5929,6419],0); -ELEMENTS[63342] = Fluid3D([3538,3573,3114,3244],0); -ELEMENTS[63343] = Fluid3D([9016,9142,9481,8750],0); -ELEMENTS[63344] = Fluid3D([11578,11885,11601,10699],0); -ELEMENTS[63345] = Fluid3D([15257,15642,15714,15703],0); -ELEMENTS[63346] = Fluid3D([11238,12275,11776,11917],0); -ELEMENTS[63347] = Fluid3D([12275,11776,11917,12351],0); -ELEMENTS[63348] = Fluid3D([16539,16556,16177,16230],0); -ELEMENTS[63349] = Fluid3D([7061,7543,6449,6821],0); -ELEMENTS[63350] = Fluid3D([6449,7061,6821,6223],0); -ELEMENTS[63351] = Fluid3D([15459,14939,15163,15473],0); -ELEMENTS[63352] = Fluid3D([17282,17419,16980,17164],0); -ELEMENTS[63353] = Fluid3D([14261,14267,14995,14522],0); -ELEMENTS[63354] = Fluid3D([7074,6399,7028,7263],0); -ELEMENTS[63355] = Fluid3D([7074,6399,7263,6407],0); -ELEMENTS[63356] = Fluid3D([3089,2941,3286,3386],0); -ELEMENTS[63357] = Fluid3D([3353,3569,3910,4075],0); -ELEMENTS[63358] = Fluid3D([12647,13345,12979,13876],0); -ELEMENTS[63359] = Fluid3D([5028,5671,5651,5608],0); -ELEMENTS[63360] = Fluid3D([2544,2500,2213,2287],0); -ELEMENTS[63361] = Fluid3D([6014,6316,5908,5601],0); -ELEMENTS[63362] = Fluid3D([10542,11303,10410,11359],0); -ELEMENTS[63363] = Fluid3D([5393,5697,5921,5949],0); -ELEMENTS[63364] = Fluid3D([3424,3672,3415,3573],0); -ELEMENTS[63365] = Fluid3D([13953,13189,13917,13845],0); -ELEMENTS[63366] = Fluid3D([4693,4798,5229,4793],0); -ELEMENTS[63367] = Fluid3D([16800,16644,16986,16516],0); -ELEMENTS[63368] = Fluid3D([16333,15998,16617,16416],0); -ELEMENTS[63369] = Fluid3D([13731,14527,14340,13503],0); -ELEMENTS[63370] = Fluid3D([11941,12324,12832,12664],0); -ELEMENTS[63371] = Fluid3D([2564,2713,2995,2420],0); -ELEMENTS[63372] = Fluid3D([9108,8734,9853,9207],0); -ELEMENTS[63373] = Fluid3D([9108,8734,9207,8209],0); -ELEMENTS[63374] = Fluid3D([8310,7485,8044,7852],0); -ELEMENTS[63375] = Fluid3D([4286,4610,4810,4101],0); -ELEMENTS[63376] = Fluid3D([13567,14113,13640,13728],0); -ELEMENTS[63377] = Fluid3D([13567,14113,13728,13426],0); -ELEMENTS[63378] = Fluid3D([15704,15317,15715,15686],0); -ELEMENTS[63379] = Fluid3D([17097,17257,17087,17381],0); -ELEMENTS[63380] = Fluid3D([17087,17097,17381,17017],0); -ELEMENTS[63381] = Fluid3D([17381,17087,17017,17350],0); -ELEMENTS[63382] = Fluid3D([17257,17087,17381,17481],0); -ELEMENTS[63383] = Fluid3D([5261,4884,4849,5605],0); -ELEMENTS[63384] = Fluid3D([14507,14159,14255,13720],0); -ELEMENTS[63385] = Fluid3D([14507,14159,13720,13349],0); -ELEMENTS[63386] = Fluid3D([4737,4467,4324,4637],0); -ELEMENTS[63387] = Fluid3D([16085,16241,16612,16350],0); -ELEMENTS[63388] = Fluid3D([9924,10384,9664,10959],0); -ELEMENTS[63389] = Fluid3D([9999,9328,10753,10048],0); -ELEMENTS[63390] = Fluid3D([8816,8333,9463,8612],0); -ELEMENTS[63391] = Fluid3D([13530,13598,13444,14106],0); -ELEMENTS[63392] = Fluid3D([15073,14541,14661,15234],0); -ELEMENTS[63393] = Fluid3D([5215,4838,4983,5353],0); -ELEMENTS[63394] = Fluid3D([5215,4838,5353,5409],0); -ELEMENTS[63395] = Fluid3D([4983,5215,5353,5754],0); -ELEMENTS[63396] = Fluid3D([4838,5353,5409,4673],0); -ELEMENTS[63397] = Fluid3D([5353,5215,5409,5716],0); -ELEMENTS[63398] = Fluid3D([5409,5353,5716,5449],0); -ELEMENTS[63399] = Fluid3D([5353,5716,5449,5754],0); -ELEMENTS[63400] = Fluid3D([5353,5215,5716,5754],0); -ELEMENTS[63401] = Fluid3D([5409,5353,5449,4673],0); -ELEMENTS[63402] = Fluid3D([4838,5353,4673,4983],0); -ELEMENTS[63403] = Fluid3D([11553,12171,11001,11618],0); -ELEMENTS[63404] = Fluid3D([8684,9316,8672,8859],0); -ELEMENTS[63405] = Fluid3D([14028,14228,13750,13360],0); -ELEMENTS[63406] = Fluid3D([4353,3877,4181,4423],0); -ELEMENTS[63407] = Fluid3D([10437,10316,10222,9310],0); -ELEMENTS[63408] = Fluid3D([13973,13683,14306,14668],0); -ELEMENTS[63409] = Fluid3D([13973,13683,14668,13983],0); -ELEMENTS[63410] = Fluid3D([13973,13683,13983,13499],0); -ELEMENTS[63411] = Fluid3D([13983,13973,13499,14335],0); -ELEMENTS[63412] = Fluid3D([13499,13983,14335,13804],0); -ELEMENTS[63413] = Fluid3D([13499,13983,13804,13683],0); -ELEMENTS[63414] = Fluid3D([13983,13804,13683,14542],0); -ELEMENTS[63415] = Fluid3D([13983,13804,14542,14335],0); -ELEMENTS[63416] = Fluid3D([14668,13973,13983,14335],0); -ELEMENTS[63417] = Fluid3D([14542,13983,14335,14668],0); -ELEMENTS[63418] = Fluid3D([14542,13983,14668,13683],0); -ELEMENTS[63419] = Fluid3D([7117,6257,6698,6456],0); -ELEMENTS[63420] = Fluid3D([15639,16058,15901,15732],0); -ELEMENTS[63421] = Fluid3D([12126,11886,10876,11185],0); -ELEMENTS[63422] = Fluid3D([17599,17537,17881,17484],0); -ELEMENTS[63423] = Fluid3D([11552,12239,11046,11232],0); -ELEMENTS[63424] = Fluid3D([10009,9925,9641,8709],0); -ELEMENTS[63425] = Fluid3D([18215,18310,18412,18378],0); -ELEMENTS[63426] = Fluid3D([4106,4443,4112,3966],0); -ELEMENTS[63427] = Fluid3D([4106,4443,3966,4035],0); -ELEMENTS[63428] = Fluid3D([4112,4106,3966,3744],0); -ELEMENTS[63429] = Fluid3D([4112,4106,3744,4204],0); -ELEMENTS[63430] = Fluid3D([4112,4106,4204,4742],0); -ELEMENTS[63431] = Fluid3D([4106,3966,3744,4035],0); -ELEMENTS[63432] = Fluid3D([3744,4106,4035,4204],0); -ELEMENTS[63433] = Fluid3D([3744,4112,4204,3783],0); -ELEMENTS[63434] = Fluid3D([3966,3744,4035,3534],0); -ELEMENTS[63435] = Fluid3D([3744,4035,3534,3801],0); -ELEMENTS[63436] = Fluid3D([3534,3744,3801,3369],0); -ELEMENTS[63437] = Fluid3D([3534,3744,3369,3659],0); -ELEMENTS[63438] = Fluid3D([3744,3369,3659,3783],0); -ELEMENTS[63439] = Fluid3D([3534,3744,3659,3966],0); -ELEMENTS[63440] = Fluid3D([3744,3659,3966,4112],0); -ELEMENTS[63441] = Fluid3D([3744,3659,4112,3783],0); -ELEMENTS[63442] = Fluid3D([3744,3801,3369,3783],0); -ELEMENTS[63443] = Fluid3D([3659,3966,4112,3995],0); -ELEMENTS[63444] = Fluid3D([4112,3659,3995,3782],0); -ELEMENTS[63445] = Fluid3D([4443,3966,4035,4449],0); -ELEMENTS[63446] = Fluid3D([11056,11484,12000,11349],0); -ELEMENTS[63447] = Fluid3D([11056,11484,11349,10245],0); -ELEMENTS[63448] = Fluid3D([11056,11484,10245,10428],0); -ELEMENTS[63449] = Fluid3D([17810,17949,18103,17958],0); -ELEMENTS[63450] = Fluid3D([9895,9699,9741,9095],0); -ELEMENTS[63451] = Fluid3D([9741,9895,9095,10014],0); -ELEMENTS[63452] = Fluid3D([5394,5544,5821,5485],0); -ELEMENTS[63453] = Fluid3D([3862,4175,4171,4441],0); -ELEMENTS[63454] = Fluid3D([13282,13300,13731,12667],0); -ELEMENTS[63455] = Fluid3D([5536,5725,5971,6460],0); -ELEMENTS[63456] = Fluid3D([7567,7523,6627,7355],0); -ELEMENTS[63457] = Fluid3D([7567,7523,7355,8043],0); -ELEMENTS[63458] = Fluid3D([7403,6821,7621,7543],0); -ELEMENTS[63459] = Fluid3D([8329,8193,7786,7447],0); -ELEMENTS[63460] = Fluid3D([15483,15128,14645,15155],0); -ELEMENTS[63461] = Fluid3D([15483,15128,15155,15384],0); -ELEMENTS[63462] = Fluid3D([13353,12705,13125,13505],0); -ELEMENTS[63463] = Fluid3D([5928,5456,5848,6173],0); -ELEMENTS[63464] = Fluid3D([5461,5109,4669,5164],0); -ELEMENTS[63465] = Fluid3D([15616,16100,15981,15341],0); -ELEMENTS[63466] = Fluid3D([13880,13794,13016,13234],0); -ELEMENTS[63467] = Fluid3D([7971,8289,8747,7635],0); -ELEMENTS[63468] = Fluid3D([12059,11120,11196,11323],0); -ELEMENTS[63469] = Fluid3D([12059,11120,11323,11880],0); -ELEMENTS[63470] = Fluid3D([11323,12059,11880,11763],0); -ELEMENTS[63471] = Fluid3D([11880,11323,11763,10345],0); -ELEMENTS[63472] = Fluid3D([11120,11323,11880,10713],0); -ELEMENTS[63473] = Fluid3D([11323,11880,10713,10345],0); -ELEMENTS[63474] = Fluid3D([10713,11323,10345,11120],0); -ELEMENTS[63475] = Fluid3D([11120,11196,11323,10199],0); -ELEMENTS[63476] = Fluid3D([11196,12059,11323,11994],0); -ELEMENTS[63477] = Fluid3D([12059,11323,11994,11763],0); -ELEMENTS[63478] = Fluid3D([11323,11994,11763,10893],0); -ELEMENTS[63479] = Fluid3D([11323,11196,11994,10893],0); -ELEMENTS[63480] = Fluid3D([11196,12059,11994,12624],0); -ELEMENTS[63481] = Fluid3D([12059,11994,12624,12568],0); -ELEMENTS[63482] = Fluid3D([12059,11994,12568,11763],0); -ELEMENTS[63483] = Fluid3D([11994,12568,11763,12680],0); -ELEMENTS[63484] = Fluid3D([11994,12568,12680,12624],0); -ELEMENTS[63485] = Fluid3D([12680,11994,12624,11947],0); -ELEMENTS[63486] = Fluid3D([12680,11994,11947,11993],0); -ELEMENTS[63487] = Fluid3D([11994,12624,11947,11196],0); -ELEMENTS[63488] = Fluid3D([11947,11994,11196,10893],0); -ELEMENTS[63489] = Fluid3D([11880,10713,10345,11360],0); -ELEMENTS[63490] = Fluid3D([11880,10713,11360,10387],0); -ELEMENTS[63491] = Fluid3D([11880,10713,10387,11008],0); -ELEMENTS[63492] = Fluid3D([10713,10387,11008,10019],0); -ELEMENTS[63493] = Fluid3D([10713,10387,10019,10345],0); -ELEMENTS[63494] = Fluid3D([10713,10387,10345,11360],0); -ELEMENTS[63495] = Fluid3D([11008,10713,10019,11120],0); -ELEMENTS[63496] = Fluid3D([10019,10713,10345,11120],0); -ELEMENTS[63497] = Fluid3D([11008,10713,11120,11880],0); -ELEMENTS[63498] = Fluid3D([10387,10019,10345,9485],0); -ELEMENTS[63499] = Fluid3D([10387,10019,9485,9693],0); -ELEMENTS[63500] = Fluid3D([10387,11008,10019,9693],0); -ELEMENTS[63501] = Fluid3D([10345,10387,9485,10515],0); -ELEMENTS[63502] = Fluid3D([10345,10387,10515,11360],0); -ELEMENTS[63503] = Fluid3D([10387,10515,11360,10603],0); -ELEMENTS[63504] = Fluid3D([10019,11008,11120,10137],0); -ELEMENTS[63505] = Fluid3D([10019,11008,10137,9693],0); -ELEMENTS[63506] = Fluid3D([10137,10019,9693,9144],0); -ELEMENTS[63507] = Fluid3D([10137,10019,9144,10187],0); -ELEMENTS[63508] = Fluid3D([10137,10019,10187,11120],0); -ELEMENTS[63509] = Fluid3D([9693,10137,9144,8805],0); -ELEMENTS[63510] = Fluid3D([9144,10137,10187,9091],0); -ELEMENTS[63511] = Fluid3D([9144,10137,9091,9764],0); -ELEMENTS[63512] = Fluid3D([9144,9693,8805,8473],0); -ELEMENTS[63513] = Fluid3D([8805,9144,8473,9091],0); -ELEMENTS[63514] = Fluid3D([9144,8473,9091,8575],0); -ELEMENTS[63515] = Fluid3D([9091,9144,8575,9648],0); -ELEMENTS[63516] = Fluid3D([9144,8473,8575,8913],0); -ELEMENTS[63517] = Fluid3D([10137,10187,9091,9892],0); -ELEMENTS[63518] = Fluid3D([10137,10187,9892,11203],0); -ELEMENTS[63519] = Fluid3D([8805,9144,9091,9764],0); -ELEMENTS[63520] = Fluid3D([9091,9144,9648,10187],0); -ELEMENTS[63521] = Fluid3D([10137,10187,11203,11120],0); -ELEMENTS[63522] = Fluid3D([2823,2953,2910,2598],0); -ELEMENTS[63523] = Fluid3D([8292,7861,8105,9230],0); -ELEMENTS[63524] = Fluid3D([4508,4074,4330,4913],0); -ELEMENTS[63525] = Fluid3D([3386,3536,3286,3682],0); -ELEMENTS[63526] = Fluid3D([3386,3536,3682,4025],0); -ELEMENTS[63527] = Fluid3D([11444,11620,12519,11868],0); -ELEMENTS[63528] = Fluid3D([9697,9149,8908,8271],0); -ELEMENTS[63529] = Fluid3D([11988,12289,11879,13048],0); -ELEMENTS[63530] = Fluid3D([10503,10599,10550,9567],0); -ELEMENTS[63531] = Fluid3D([13108,13635,12743,12708],0); -ELEMENTS[63532] = Fluid3D([7171,6192,6860,7133],0); -ELEMENTS[63533] = Fluid3D([6745,6994,7431,7578],0); -ELEMENTS[63534] = Fluid3D([5201,5635,5611,4907],0); -ELEMENTS[63535] = Fluid3D([17662,17268,17660,17383],0); -ELEMENTS[63536] = Fluid3D([4777,4715,4199,4159],0); -ELEMENTS[63537] = Fluid3D([10680,11081,11757,10705],0); -ELEMENTS[63538] = Fluid3D([6675,6274,6065,7068],0); -ELEMENTS[63539] = Fluid3D([13382,13891,13995,14595],0); -ELEMENTS[63540] = Fluid3D([13891,13995,14595,14943],0); -ELEMENTS[63541] = Fluid3D([10104,11089,10493,11148],0); -ELEMENTS[63542] = Fluid3D([12417,13103,13333,13652],0); -ELEMENTS[63543] = Fluid3D([12625,13097,13827,12921],0); -ELEMENTS[63544] = Fluid3D([6413,6064,5775,5772],0); -ELEMENTS[63545] = Fluid3D([6413,6064,5772,5605],0); -ELEMENTS[63546] = Fluid3D([15307,14772,15643,15493],0); -ELEMENTS[63547] = Fluid3D([10725,10642,11665,10975],0); -ELEMENTS[63548] = Fluid3D([3289,3452,3592,3908],0); -ELEMENTS[63549] = Fluid3D([3347,2961,3128,3069],0); -ELEMENTS[63550] = Fluid3D([8342,7815,8396,8170],0); -ELEMENTS[63551] = Fluid3D([10194,9613,10131,11103],0); -ELEMENTS[63552] = Fluid3D([10131,10194,11103,11064],0); -ELEMENTS[63553] = Fluid3D([10194,11103,11064,10298],0); -ELEMENTS[63554] = Fluid3D([18238,18333,18252,17980],0); -ELEMENTS[63555] = Fluid3D([12913,13035,13509,13919],0); -ELEMENTS[63556] = Fluid3D([12833,13237,13784,13674],0); -ELEMENTS[63557] = Fluid3D([12561,12324,12385,13231],0); -ELEMENTS[63558] = Fluid3D([12433,12776,11676,12457],0); -ELEMENTS[63559] = Fluid3D([2683,2400,2664,2718],0); -ELEMENTS[63560] = Fluid3D([15724,15728,16121,15319],0); -ELEMENTS[63561] = Fluid3D([10224,10350,9438,9173],0); -ELEMENTS[63562] = Fluid3D([10350,9438,9173,9598],0); -ELEMENTS[63563] = Fluid3D([16069,15815,16437,16514],0); -ELEMENTS[63564] = Fluid3D([17835,17919,18106,17883],0); -ELEMENTS[63565] = Fluid3D([8755,9703,9662,10344],0); -ELEMENTS[63566] = Fluid3D([9703,9662,10344,10572],0); -ELEMENTS[63567] = Fluid3D([10344,9703,10572,10289],0); -ELEMENTS[63568] = Fluid3D([10344,9703,10289,9375],0); -ELEMENTS[63569] = Fluid3D([9662,10344,10572,10430],0); -ELEMENTS[63570] = Fluid3D([9662,10344,10430,9966],0); -ELEMENTS[63571] = Fluid3D([8786,7910,7545,8124],0); -ELEMENTS[63572] = Fluid3D([17984,17894,18151,17945],0); -ELEMENTS[63573] = Fluid3D([5138,5166,5409,5853],0); -ELEMENTS[63574] = Fluid3D([16695,16320,16677,16810],0); -ELEMENTS[63575] = Fluid3D([4710,4417,4953,5107],0); -ELEMENTS[63576] = Fluid3D([16426,16001,16778,16500],0); -ELEMENTS[63577] = Fluid3D([17813,17887,17722,18063],0); -ELEMENTS[63578] = Fluid3D([13563,13868,14397,13668],0); -ELEMENTS[63579] = Fluid3D([13868,14397,13668,13955],0); -ELEMENTS[63580] = Fluid3D([4680,5110,5296,4874],0); -ELEMENTS[63581] = Fluid3D([6921,6261,7432,7272],0); -ELEMENTS[63582] = Fluid3D([7432,6921,7272,7443],0); -ELEMENTS[63583] = Fluid3D([6921,6261,7272,6677],0); -ELEMENTS[63584] = Fluid3D([18024,17930,17747,17671],0); -ELEMENTS[63585] = Fluid3D([17747,18024,17671,17731],0); -ELEMENTS[63586] = Fluid3D([14045,14789,14364,14767],0); -ELEMENTS[63587] = Fluid3D([2880,2961,2590,3128],0); -ELEMENTS[63588] = Fluid3D([13749,13392,14529,13760],0); -ELEMENTS[63589] = Fluid3D([13936,13653,14042,13702],0); -ELEMENTS[63590] = Fluid3D([13653,14042,13702,12629],0); -ELEMENTS[63591] = Fluid3D([13912,14292,13403,13688],0); -ELEMENTS[63592] = Fluid3D([5908,5448,5601,5417],0); -ELEMENTS[63593] = Fluid3D([18419,18490,18563,18476],0); -ELEMENTS[63594] = Fluid3D([2239,2226,2047,1992],0); -ELEMENTS[63595] = Fluid3D([17903,17586,17945,17912],0); -ELEMENTS[63596] = Fluid3D([14791,15150,15522,14645],0); -ELEMENTS[63597] = Fluid3D([14791,15150,14645,14400],0); -ELEMENTS[63598] = Fluid3D([8876,9281,9851,8934],0); -ELEMENTS[63599] = Fluid3D([8876,9281,8934,8046],0); -ELEMENTS[63600] = Fluid3D([17765,18002,17906,17689],0); -ELEMENTS[63601] = Fluid3D([18002,17906,17689,17785],0); -ELEMENTS[63602] = Fluid3D([17689,18002,17785,17649],0); -ELEMENTS[63603] = Fluid3D([17785,17689,17649,17384],0); -ELEMENTS[63604] = Fluid3D([17689,18002,17649,17765],0); -ELEMENTS[63605] = Fluid3D([17689,17649,17384,17765],0); -ELEMENTS[63606] = Fluid3D([17785,17689,17384,17784],0); -ELEMENTS[63607] = Fluid3D([17785,17689,17784,17906],0); -ELEMENTS[63608] = Fluid3D([17689,17784,17906,17384],0); -ELEMENTS[63609] = Fluid3D([17784,17785,17906,18118],0); -ELEMENTS[63610] = Fluid3D([17906,17784,18118,17941],0); -ELEMENTS[63611] = Fluid3D([17906,17784,17941,17681],0); -ELEMENTS[63612] = Fluid3D([17906,17784,17681,17384],0); -ELEMENTS[63613] = Fluid3D([17906,17765,17689,17384],0); -ELEMENTS[63614] = Fluid3D([5598,5793,6054,5218],0); -ELEMENTS[63615] = Fluid3D([6873,7235,6164,6986],0); -ELEMENTS[63616] = Fluid3D([6873,7235,6986,7723],0); -ELEMENTS[63617] = Fluid3D([6164,6873,6986,6530],0); -ELEMENTS[63618] = Fluid3D([6873,6986,6530,7299],0); -ELEMENTS[63619] = Fluid3D([6873,6986,7299,7723],0); -ELEMENTS[63620] = Fluid3D([4889,4464,4292,4302],0); -ELEMENTS[63621] = Fluid3D([15306,15019,15015,15617],0); -ELEMENTS[63622] = Fluid3D([16842,16418,16740,16029],0); -ELEMENTS[63623] = Fluid3D([14788,14969,14176,14188],0); -ELEMENTS[63624] = Fluid3D([14969,14176,14188,14944],0); -ELEMENTS[63625] = Fluid3D([14969,14176,14944,15186],0); -ELEMENTS[63626] = Fluid3D([14944,14969,15186,15649],0); -ELEMENTS[63627] = Fluid3D([14788,14969,14188,14892],0); -ELEMENTS[63628] = Fluid3D([14270,14183,14081,15149],0); -ELEMENTS[63629] = Fluid3D([7483,7851,6969,6742],0); -ELEMENTS[63630] = Fluid3D([4992,5069,5663,5234],0); -ELEMENTS[63631] = Fluid3D([10861,10464,9906,11134],0); -ELEMENTS[63632] = Fluid3D([11391,11613,11547,10847],0); -ELEMENTS[63633] = Fluid3D([11613,11547,10847,10951],0); -ELEMENTS[63634] = Fluid3D([11547,10847,10951,11007],0); -ELEMENTS[63635] = Fluid3D([11547,10847,11007,11175],0); -ELEMENTS[63636] = Fluid3D([11547,10847,11175,11391],0); -ELEMENTS[63637] = Fluid3D([7602,7086,6909,7072],0); -ELEMENTS[63638] = Fluid3D([7602,7086,7072,7958],0); -ELEMENTS[63639] = Fluid3D([16998,16727,16560,16512],0); -ELEMENTS[63640] = Fluid3D([3928,3917,4315,4287],0); -ELEMENTS[63641] = Fluid3D([7376,7690,7962,7192],0); -ELEMENTS[63642] = Fluid3D([9576,9839,10191,10870],0); -ELEMENTS[63643] = Fluid3D([3851,3681,3441,3667],0); -ELEMENTS[63644] = Fluid3D([15850,16189,15577,15892],0); -ELEMENTS[63645] = Fluid3D([9215,9171,9610,8432],0); -ELEMENTS[63646] = Fluid3D([12115,11455,11644,11685],0); -ELEMENTS[63647] = Fluid3D([14625,14321,15399,14604],0); -ELEMENTS[63648] = Fluid3D([15162,15549,15236,15784],0); -ELEMENTS[63649] = Fluid3D([3659,3538,3542,3966],0); -ELEMENTS[63650] = Fluid3D([16692,16942,17347,17115],0); -ELEMENTS[63651] = Fluid3D([11979,11339,11379,11044],0); -ELEMENTS[63652] = Fluid3D([10596,10807,11591,11447],0); -ELEMENTS[63653] = Fluid3D([15384,15556,16249,15890],0); -ELEMENTS[63654] = Fluid3D([13736,13259,13884,13373],0); -ELEMENTS[63655] = Fluid3D([13736,13259,13373,12754],0); -ELEMENTS[63656] = Fluid3D([2364,2740,2512,2677],0); -ELEMENTS[63657] = Fluid3D([15875,16321,16048,16033],0); -ELEMENTS[63658] = Fluid3D([15875,16321,16033,16665],0); -ELEMENTS[63659] = Fluid3D([15893,15876,15643,16311],0); -ELEMENTS[63660] = Fluid3D([15990,16205,15774,16314],0); -ELEMENTS[63661] = Fluid3D([16893,16513,16947,16369],0); -ELEMENTS[63662] = Fluid3D([10006,9683,8886,9404],0); -ELEMENTS[63663] = Fluid3D([5035,4769,5564,5220],0); -ELEMENTS[63664] = Fluid3D([11807,11441,11257,10540],0); -ELEMENTS[63665] = Fluid3D([11441,11257,10540,10509],0); -ELEMENTS[63666] = Fluid3D([16638,16790,17045,17224],0); -ELEMENTS[63667] = Fluid3D([16134,15637,15988,16084],0); -ELEMENTS[63668] = Fluid3D([15637,15988,16084,15346],0); -ELEMENTS[63669] = Fluid3D([5279,5889,5091,5402],0); -ELEMENTS[63670] = Fluid3D([13878,14079,13331,14198],0); -ELEMENTS[63671] = Fluid3D([4783,4222,4352,4912],0); -ELEMENTS[63672] = Fluid3D([11963,11149,12348,11604],0); -ELEMENTS[63673] = Fluid3D([11149,12348,11604,11367],0); -ELEMENTS[63674] = Fluid3D([11604,11149,11367,10896],0); -ELEMENTS[63675] = Fluid3D([11604,11149,10896,10089],0); -ELEMENTS[63676] = Fluid3D([13431,13205,14322,13521],0); -ELEMENTS[63677] = Fluid3D([13431,13205,13521,12763],0); -ELEMENTS[63678] = Fluid3D([14322,13431,13521,13855],0); -ELEMENTS[63679] = Fluid3D([13431,13521,13855,12763],0); -ELEMENTS[63680] = Fluid3D([5727,6331,5527,5957],0); -ELEMENTS[63681] = Fluid3D([5902,5671,5319,6110],0); -ELEMENTS[63682] = Fluid3D([3231,3528,3050,3157],0); -ELEMENTS[63683] = Fluid3D([17033,16776,16474,16913],0); -ELEMENTS[63684] = Fluid3D([13614,13241,14196,13028],0); -ELEMENTS[63685] = Fluid3D([13614,13241,13028,12747],0); -ELEMENTS[63686] = Fluid3D([13241,13028,12747,12243],0); -ELEMENTS[63687] = Fluid3D([10803,10371,9943,10770],0); -ELEMENTS[63688] = Fluid3D([7424,7851,7391,6742],0); -ELEMENTS[63689] = Fluid3D([9009,8816,9463,10098],0); -ELEMENTS[63690] = Fluid3D([14872,15624,15524,15340],0); -ELEMENTS[63691] = Fluid3D([6281,6042,6725,6853],0); -ELEMENTS[63692] = Fluid3D([6829,6073,6608,6708],0); -ELEMENTS[63693] = Fluid3D([13608,12870,12637,13634],0); -ELEMENTS[63694] = Fluid3D([4407,4068,4528,4711],0); -ELEMENTS[63695] = Fluid3D([2269,2381,2234,2147],0); -ELEMENTS[63696] = Fluid3D([2269,2381,2147,2018],0); -ELEMENTS[63697] = Fluid3D([7600,7650,8405,7721],0); -ELEMENTS[63698] = Fluid3D([17222,17311,17333,16967],0); -ELEMENTS[63699] = Fluid3D([14319,13799,13626,14564],0); -ELEMENTS[63700] = Fluid3D([16782,16554,16769,17143],0); -ELEMENTS[63701] = Fluid3D([10069,9849,10847,10325],0); -ELEMENTS[63702] = Fluid3D([5403,4963,4910,5613],0); -ELEMENTS[63703] = Fluid3D([9636,8891,8615,8488],0); -ELEMENTS[63704] = Fluid3D([15644,15268,15726,15849],0); -ELEMENTS[63705] = Fluid3D([8843,8441,9135,9857],0); -ELEMENTS[63706] = Fluid3D([11134,11638,10288,10861],0); -ELEMENTS[63707] = Fluid3D([12573,12560,13303,13154],0); -ELEMENTS[63708] = Fluid3D([13303,12573,13154,13100],0); -ELEMENTS[63709] = Fluid3D([12573,12560,13154,12657],0); -ELEMENTS[63710] = Fluid3D([8226,8584,8471,9506],0); -ELEMENTS[63711] = Fluid3D([7011,7209,7128,6534],0); -ELEMENTS[63712] = Fluid3D([16361,16719,16697,16750],0); -ELEMENTS[63713] = Fluid3D([16361,16719,16750,16717],0); -ELEMENTS[63714] = Fluid3D([11241,11197,12283,12163],0); -ELEMENTS[63715] = Fluid3D([5107,5637,5087,5174],0); -ELEMENTS[63716] = Fluid3D([15799,15057,15551,15389],0); -ELEMENTS[63717] = Fluid3D([10903,11475,10429,11815],0); -ELEMENTS[63718] = Fluid3D([10903,11475,11815,11590],0); -ELEMENTS[63719] = Fluid3D([14507,14616,13720,14286],0); -ELEMENTS[63720] = Fluid3D([5588,6191,6063,5783],0); -ELEMENTS[63721] = Fluid3D([2602,2994,2800,2849],0); -ELEMENTS[63722] = Fluid3D([14048,14161,14922,14431],0); -ELEMENTS[63723] = Fluid3D([18307,18420,18206,18452],0); -ELEMENTS[63724] = Fluid3D([18206,18307,18452,18370],0); -ELEMENTS[63725] = Fluid3D([18206,18307,18370,18165],0); -ELEMENTS[63726] = Fluid3D([18307,18420,18452,18517],0); -ELEMENTS[63727] = Fluid3D([17805,17492,17560,17645],0); -ELEMENTS[63728] = Fluid3D([11478,10800,11887,11395],0); -ELEMENTS[63729] = Fluid3D([18497,18582,18486,18559],0); -ELEMENTS[63730] = Fluid3D([4428,4117,4620,4637],0); -ELEMENTS[63731] = Fluid3D([12955,12310,12899,12114],0); -ELEMENTS[63732] = Fluid3D([13611,14439,14181,13596],0); -ELEMENTS[63733] = Fluid3D([13639,14394,14294,13897],0); -ELEMENTS[63734] = Fluid3D([16546,16743,16866,16565],0); -ELEMENTS[63735] = Fluid3D([18137,18227,18196,17959],0); -ELEMENTS[63736] = Fluid3D([18137,18227,17959,17770],0); -ELEMENTS[63737] = Fluid3D([15882,15943,16199,16363],0); -ELEMENTS[63738] = Fluid3D([2057,1948,2167,1955],0); -ELEMENTS[63739] = Fluid3D([7623,7275,7289,6639],0); -ELEMENTS[63740] = Fluid3D([1795,1698,1693,1811],0); -ELEMENTS[63741] = Fluid3D([1693,1795,1811,1932],0); -ELEMENTS[63742] = Fluid3D([1698,1693,1811,1759],0); -ELEMENTS[63743] = Fluid3D([1795,1811,1932,2009],0); -ELEMENTS[63744] = Fluid3D([6872,6304,6576,6769],0); -ELEMENTS[63745] = Fluid3D([11710,12307,11413,12085],0); -ELEMENTS[63746] = Fluid3D([18537,18534,18626,18564],0); -ELEMENTS[63747] = Fluid3D([4537,4144,4226,4240],0); -ELEMENTS[63748] = Fluid3D([7222,7377,6505,6245],0); -ELEMENTS[63749] = Fluid3D([9992,10907,10302,10405],0); -ELEMENTS[63750] = Fluid3D([10587,10317,11566,11022],0); -ELEMENTS[63751] = Fluid3D([14755,15163,14470,14030],0); -ELEMENTS[63752] = Fluid3D([2626,2546,2899,3108],0); -ELEMENTS[63753] = Fluid3D([5137,4875,4839,4777],0); -ELEMENTS[63754] = Fluid3D([10480,10922,11269,10718],0); -ELEMENTS[63755] = Fluid3D([11964,12817,12180,12965],0); -ELEMENTS[63756] = Fluid3D([14876,15257,14233,15060],0); -ELEMENTS[63757] = Fluid3D([14876,15257,15060,15302],0); -ELEMENTS[63758] = Fluid3D([14876,15257,15302,15720],0); -ELEMENTS[63759] = Fluid3D([13854,13840,14627,13654],0); -ELEMENTS[63760] = Fluid3D([12494,11654,12840,11601],0); -ELEMENTS[63761] = Fluid3D([12494,11654,11601,11923],0); -ELEMENTS[63762] = Fluid3D([12494,11654,11923,11498],0); -ELEMENTS[63763] = Fluid3D([14025,14097,14764,14311],0); -ELEMENTS[63764] = Fluid3D([12670,12262,12164,12883],0); -ELEMENTS[63765] = Fluid3D([12262,12164,12883,12837],0); -ELEMENTS[63766] = Fluid3D([12670,12262,12883,13407],0); -ELEMENTS[63767] = Fluid3D([12262,12883,13407,12837],0); -ELEMENTS[63768] = Fluid3D([17682,17849,17583,17407],0); -ELEMENTS[63769] = Fluid3D([10464,11241,11134,10861],0); -ELEMENTS[63770] = Fluid3D([10464,11241,10861,11317],0); -ELEMENTS[63771] = Fluid3D([10472,9616,10458,10114],0); -ELEMENTS[63772] = Fluid3D([10722,10099,10193,11726],0); -ELEMENTS[63773] = Fluid3D([4014,3629,3596,3546],0); -ELEMENTS[63774] = Fluid3D([12924,13198,12723,13579],0); -ELEMENTS[63775] = Fluid3D([12924,13198,13579,13926],0); -ELEMENTS[63776] = Fluid3D([12924,13198,13926,13774],0); -ELEMENTS[63777] = Fluid3D([13198,13926,13774,13616],0); -ELEMENTS[63778] = Fluid3D([13198,13579,13926,13153],0); -ELEMENTS[63779] = Fluid3D([12924,13198,13774,12925],0); -ELEMENTS[63780] = Fluid3D([14301,14998,14031,13702],0); -ELEMENTS[63781] = Fluid3D([7980,8665,8743,8647],0); -ELEMENTS[63782] = Fluid3D([16422,15838,16339,16190],0); -ELEMENTS[63783] = Fluid3D([6813,6237,5812,6803],0); -ELEMENTS[63784] = Fluid3D([17495,17473,17446,16957],0); -ELEMENTS[63785] = Fluid3D([4718,4797,5178,4600],0); -ELEMENTS[63786] = Fluid3D([12373,13116,13138,13715],0); -ELEMENTS[63787] = Fluid3D([18219,17960,18160,17840],0); -ELEMENTS[63788] = Fluid3D([18219,17960,17840,17948],0); -ELEMENTS[63789] = Fluid3D([7093,6339,6916,6887],0); -ELEMENTS[63790] = Fluid3D([12902,12641,11581,12760],0); -ELEMENTS[63791] = Fluid3D([12902,12641,12760,13616],0); -ELEMENTS[63792] = Fluid3D([12291,12975,11508,11968],0); -ELEMENTS[63793] = Fluid3D([3601,3562,3253,3765],0); -ELEMENTS[63794] = Fluid3D([12379,13163,13146,13304],0); -ELEMENTS[63795] = Fluid3D([5272,5276,4753,4832],0); -ELEMENTS[63796] = Fluid3D([16072,15725,16376,16014],0); -ELEMENTS[63797] = Fluid3D([16376,16072,16014,16730],0); -ELEMENTS[63798] = Fluid3D([8116,8096,7728,6923],0); -ELEMENTS[63799] = Fluid3D([3329,3175,3482,3050],0); -ELEMENTS[63800] = Fluid3D([16060,16137,16269,15716],0); -ELEMENTS[63801] = Fluid3D([18276,18480,18510,18363],0); -ELEMENTS[63802] = Fluid3D([8748,9130,8073,8621],0); -ELEMENTS[63803] = Fluid3D([6273,5695,6258,5562],0); -ELEMENTS[63804] = Fluid3D([11824,12248,11080,10812],0); -ELEMENTS[63805] = Fluid3D([11080,11824,10812,10969],0); -ELEMENTS[63806] = Fluid3D([16253,15644,16207,15849],0); -ELEMENTS[63807] = Fluid3D([13179,13589,12871,12478],0); -ELEMENTS[63808] = Fluid3D([13804,13057,12948,14074],0); -ELEMENTS[63809] = Fluid3D([3506,3418,3598,3138],0); -ELEMENTS[63810] = Fluid3D([16164,15960,16350,16464],0); -ELEMENTS[63811] = Fluid3D([3864,3985,3583,3492],0); -ELEMENTS[63812] = Fluid3D([16627,16847,16653,16242],0); -ELEMENTS[63813] = Fluid3D([16627,16847,16242,16688],0); -ELEMENTS[63814] = Fluid3D([3013,3026,3273,3267],0); -ELEMENTS[63815] = Fluid3D([17461,17384,17198,17681],0); -ELEMENTS[63816] = Fluid3D([10614,10978,11117,11147],0); -ELEMENTS[63817] = Fluid3D([13421,14012,13366,13110],0); -ELEMENTS[63818] = Fluid3D([18108,18036,18177,17692],0); -ELEMENTS[63819] = Fluid3D([15303,15951,15660,16080],0); -ELEMENTS[63820] = Fluid3D([18650,18652,18673,18690],0); -ELEMENTS[63821] = Fluid3D([17208,17195,17410,16888],0); -ELEMENTS[63822] = Fluid3D([7068,6922,7044,6274],0); -ELEMENTS[63823] = Fluid3D([15830,16467,16071,16799],0); -ELEMENTS[63824] = Fluid3D([2516,2447,2561,2788],0); -ELEMENTS[63825] = Fluid3D([2516,2447,2788,2590],0); -ELEMENTS[63826] = Fluid3D([15290,15902,15433,15393],0); -ELEMENTS[63827] = Fluid3D([10405,11166,10637,11861],0); -ELEMENTS[63828] = Fluid3D([11102,11639,12025,11201],0); -ELEMENTS[63829] = Fluid3D([11102,11639,11201,10659],0); -ELEMENTS[63830] = Fluid3D([15488,16105,15655,15673],0); -ELEMENTS[63831] = Fluid3D([16105,15655,15673,16454],0); -ELEMENTS[63832] = Fluid3D([5771,6166,6259,6615],0); -ELEMENTS[63833] = Fluid3D([13479,13446,14229,14571],0); -ELEMENTS[63834] = Fluid3D([17361,16916,17043,17129],0); -ELEMENTS[63835] = Fluid3D([15862,16149,15668,15470],0); -ELEMENTS[63836] = Fluid3D([8806,9308,8156,8468],0); -ELEMENTS[63837] = Fluid3D([15331,15451,15901,15543],0); -ELEMENTS[63838] = Fluid3D([18460,18547,18545,18594],0); -ELEMENTS[63839] = Fluid3D([12556,12346,11732,12186],0); -ELEMENTS[63840] = Fluid3D([9517,9714,10361,9374],0); -ELEMENTS[63841] = Fluid3D([14644,13925,14768,14162],0); -ELEMENTS[63842] = Fluid3D([11890,10986,11519,11708],0); -ELEMENTS[63843] = Fluid3D([5454,5229,4834,5566],0); -ELEMENTS[63844] = Fluid3D([3492,3542,3864,4009],0); -ELEMENTS[63845] = Fluid3D([17207,17334,17411,17680],0); -ELEMENTS[63846] = Fluid3D([13812,13445,14137,14715],0); -ELEMENTS[63847] = Fluid3D([11543,11645,11300,12212],0); -ELEMENTS[63848] = Fluid3D([11588,11275,10465,11272],0); -ELEMENTS[63849] = Fluid3D([14400,14957,14783,15150],0); -ELEMENTS[63850] = Fluid3D([14400,14957,15150,14645],0); -ELEMENTS[63851] = Fluid3D([2727,2688,2635,2998],0); -ELEMENTS[63852] = Fluid3D([3066,3209,3417,3214],0); -ELEMENTS[63853] = Fluid3D([5009,4959,4441,4727],0); -ELEMENTS[63854] = Fluid3D([5009,4959,4727,5508],0); -ELEMENTS[63855] = Fluid3D([4959,4441,4727,4279],0); -ELEMENTS[63856] = Fluid3D([4727,4959,4279,4613],0); -ELEMENTS[63857] = Fluid3D([4959,4279,4613,5026],0); -ELEMENTS[63858] = Fluid3D([16210,16204,16497,15826],0); -ELEMENTS[63859] = Fluid3D([5363,5552,5944,6042],0); -ELEMENTS[63860] = Fluid3D([10359,9722,11091,10135],0); -ELEMENTS[63861] = Fluid3D([10359,9722,10135,9502],0); -ELEMENTS[63862] = Fluid3D([14698,14796,14982,15324],0); -ELEMENTS[63863] = Fluid3D([15717,16177,15874,16230],0); -ELEMENTS[63864] = Fluid3D([16177,15874,16230,15879],0); -ELEMENTS[63865] = Fluid3D([18463,18405,18280,18507],0); -ELEMENTS[63866] = Fluid3D([5682,5726,5851,5002],0); -ELEMENTS[63867] = Fluid3D([5705,5379,6293,6065],0); -ELEMENTS[63868] = Fluid3D([9792,10114,9475,8788],0); -ELEMENTS[63869] = Fluid3D([9475,9792,8788,9130],0); -ELEMENTS[63870] = Fluid3D([14257,14515,13547,13985],0); -ELEMENTS[63871] = Fluid3D([14515,13547,13985,14358],0); -ELEMENTS[63872] = Fluid3D([15463,15812,15282,15116],0); -ELEMENTS[63873] = Fluid3D([13531,12827,12557,13090],0); -ELEMENTS[63874] = Fluid3D([16804,16981,16917,16416],0); -ELEMENTS[63875] = Fluid3D([13695,13544,13908,12624],0); -ELEMENTS[63876] = Fluid3D([9095,8397,8850,7860],0); -ELEMENTS[63877] = Fluid3D([7242,7129,6365,6897],0); -ELEMENTS[63878] = Fluid3D([7242,7129,6897,7763],0); -ELEMENTS[63879] = Fluid3D([17069,17287,16718,17100],0); -ELEMENTS[63880] = Fluid3D([6445,6059,6503,6639],0); -ELEMENTS[63881] = Fluid3D([7853,8332,7652,7161],0); -ELEMENTS[63882] = Fluid3D([8332,7652,7161,7478],0); -ELEMENTS[63883] = Fluid3D([15189,14579,14738,14937],0); -ELEMENTS[63884] = Fluid3D([1924,2009,1809,1795],0); -ELEMENTS[63885] = Fluid3D([8675,7744,8045,8853],0); -ELEMENTS[63886] = Fluid3D([5943,6443,6406,6180],0); -ELEMENTS[63887] = Fluid3D([5943,6443,6180,5479],0); -ELEMENTS[63888] = Fluid3D([6180,5943,5479,5880],0); -ELEMENTS[63889] = Fluid3D([6180,5943,5880,6406],0); -ELEMENTS[63890] = Fluid3D([5943,5880,6406,5556],0); -ELEMENTS[63891] = Fluid3D([5943,5479,5880,5143],0); -ELEMENTS[63892] = Fluid3D([5880,5943,5143,5556],0); -ELEMENTS[63893] = Fluid3D([7510,7190,6915,6768],0); -ELEMENTS[63894] = Fluid3D([14598,14116,14893,13571],0); -ELEMENTS[63895] = Fluid3D([17535,17344,17151,16914],0); -ELEMENTS[63896] = Fluid3D([16063,15522,15826,16204],0); -ELEMENTS[63897] = Fluid3D([14291,13643,13818,14604],0); -ELEMENTS[63898] = Fluid3D([4446,4061,4217,3760],0); -ELEMENTS[63899] = Fluid3D([8520,8669,8365,7783],0); -ELEMENTS[63900] = Fluid3D([8669,8365,7783,7568],0); -ELEMENTS[63901] = Fluid3D([8365,7783,7568,7425],0); -ELEMENTS[63902] = Fluid3D([8520,8669,7783,8043],0); -ELEMENTS[63903] = Fluid3D([7783,7568,7425,6709],0); -ELEMENTS[63904] = Fluid3D([8669,8365,7568,8049],0); -ELEMENTS[63905] = Fluid3D([7783,8669,7568,7690],0); -ELEMENTS[63906] = Fluid3D([7568,7783,7690,6709],0); -ELEMENTS[63907] = Fluid3D([5733,5752,6372,6553],0); -ELEMENTS[63908] = Fluid3D([15533,15338,15840,15936],0); -ELEMENTS[63909] = Fluid3D([10615,11171,10855,9723],0); -ELEMENTS[63910] = Fluid3D([5452,5483,5350,4710],0); -ELEMENTS[63911] = Fluid3D([17579,17479,17729,17316],0); -ELEMENTS[63912] = Fluid3D([9550,9518,8722,9701],0); -ELEMENTS[63913] = Fluid3D([9550,9518,9701,10545],0); -ELEMENTS[63914] = Fluid3D([9518,9701,10545,10719],0); -ELEMENTS[63915] = Fluid3D([9701,10545,10719,11256],0); -ELEMENTS[63916] = Fluid3D([6334,7191,6441,6574],0); -ELEMENTS[63917] = Fluid3D([7618,8068,8692,8639],0); -ELEMENTS[63918] = Fluid3D([10173,10392,10825,11281],0); -ELEMENTS[63919] = Fluid3D([2402,2317,2511,2751],0); -ELEMENTS[63920] = Fluid3D([13532,13956,13466,12911],0); -ELEMENTS[63921] = Fluid3D([9738,9970,8988,10271],0); -ELEMENTS[63922] = Fluid3D([18167,18340,18226,17986],0); -ELEMENTS[63923] = Fluid3D([6284,5716,5754,5449],0); -ELEMENTS[63924] = Fluid3D([7634,7063,7167,8161],0); -ELEMENTS[63925] = Fluid3D([6090,5489,6234,6193],0); -ELEMENTS[63926] = Fluid3D([11814,12336,11984,11043],0); -ELEMENTS[63927] = Fluid3D([2998,3148,3290,2727],0); -ELEMENTS[63928] = Fluid3D([15873,15700,16127,16398],0); -ELEMENTS[63929] = Fluid3D([18324,18099,18220,18288],0); -ELEMENTS[63930] = Fluid3D([6995,6446,7218,7498],0); -ELEMENTS[63931] = Fluid3D([6228,6028,5656,6178],0); -ELEMENTS[63932] = Fluid3D([6028,5656,6178,6583],0); -ELEMENTS[63933] = Fluid3D([15630,15919,15651,15216],0); -ELEMENTS[63934] = Fluid3D([15630,15919,15216,15473],0); -ELEMENTS[63935] = Fluid3D([15651,15630,15216,15172],0); -ELEMENTS[63936] = Fluid3D([15630,15216,15172,15041],0); -ELEMENTS[63937] = Fluid3D([15651,15630,15172,15626],0); -ELEMENTS[63938] = Fluid3D([15630,15172,15626,15041],0); -ELEMENTS[63939] = Fluid3D([15216,15651,15172,14641],0); -ELEMENTS[63940] = Fluid3D([15172,15216,14641,14671],0); -ELEMENTS[63941] = Fluid3D([9065,9668,10021,10320],0); -ELEMENTS[63942] = Fluid3D([9457,10011,10836,10653],0); -ELEMENTS[63943] = Fluid3D([15092,15082,15429,14721],0); -ELEMENTS[63944] = Fluid3D([12759,13341,13438,13381],0); -ELEMENTS[63945] = Fluid3D([12759,13341,13381,12676],0); -ELEMENTS[63946] = Fluid3D([13438,12759,13381,12676],0); -ELEMENTS[63947] = Fluid3D([13341,13438,13381,14056],0); -ELEMENTS[63948] = Fluid3D([13438,13381,14056,13148],0); -ELEMENTS[63949] = Fluid3D([13381,13438,12676,13148],0); -ELEMENTS[63950] = Fluid3D([6399,6762,5791,6552],0); -ELEMENTS[63951] = Fluid3D([12114,11573,10960,11458],0); -ELEMENTS[63952] = Fluid3D([10875,11249,11420,10314],0); -ELEMENTS[63953] = Fluid3D([12754,12258,13136,12011],0); -ELEMENTS[63954] = Fluid3D([12754,12258,12011,12043],0); -ELEMENTS[63955] = Fluid3D([13598,12980,12928,14106],0); -ELEMENTS[63956] = Fluid3D([12519,13371,13749,13020],0); -ELEMENTS[63957] = Fluid3D([13371,13749,13020,13750],0); -ELEMENTS[63958] = Fluid3D([14568,14446,14975,14453],0); -ELEMENTS[63959] = Fluid3D([11501,10723,11954,11666],0); -ELEMENTS[63960] = Fluid3D([14758,14743,15405,15465],0); -ELEMENTS[63961] = Fluid3D([3594,3335,3070,3183],0); -ELEMENTS[63962] = Fluid3D([9816,10321,9465,9908],0); -ELEMENTS[63963] = Fluid3D([9816,10321,9908,11230],0); -ELEMENTS[63964] = Fluid3D([3868,3641,3373,3320],0); -ELEMENTS[63965] = Fluid3D([7843,7095,7668,7728],0); -ELEMENTS[63966] = Fluid3D([8163,8531,9104,9029],0); -ELEMENTS[63967] = Fluid3D([8163,8531,9029,8540],0); -ELEMENTS[63968] = Fluid3D([12437,13159,12113,12173],0); -ELEMENTS[63969] = Fluid3D([12437,13159,12173,12380],0); -ELEMENTS[63970] = Fluid3D([12113,12437,12173,11345],0); -ELEMENTS[63971] = Fluid3D([12437,12173,11345,12380],0); -ELEMENTS[63972] = Fluid3D([12173,12113,11345,12638],0); -ELEMENTS[63973] = Fluid3D([11345,12173,12638,12523],0); -ELEMENTS[63974] = Fluid3D([12173,12638,12523,13159],0); -ELEMENTS[63975] = Fluid3D([12173,12638,13159,12113],0); -ELEMENTS[63976] = Fluid3D([12667,13534,13731,13282],0); -ELEMENTS[63977] = Fluid3D([18527,18479,18375,18575],0); -ELEMENTS[63978] = Fluid3D([3507,3469,3182,3797],0); -ELEMENTS[63979] = Fluid3D([15222,14837,15709,15056],0); -ELEMENTS[63980] = Fluid3D([7114,7050,7231,7478],0); -ELEMENTS[63981] = Fluid3D([15609,16137,16028,15555],0); -ELEMENTS[63982] = Fluid3D([11089,10340,10529,11498],0); -ELEMENTS[63983] = Fluid3D([14617,14191,14321,14973],0); -ELEMENTS[63984] = Fluid3D([14617,14191,14973,14180],0); -ELEMENTS[63985] = Fluid3D([6745,6994,7578,6826],0); -ELEMENTS[63986] = Fluid3D([6745,6994,6826,6375],0); -ELEMENTS[63987] = Fluid3D([6826,6745,6375,6637],0); -ELEMENTS[63988] = Fluid3D([6375,6826,6637,7264],0); -ELEMENTS[63989] = Fluid3D([6375,6826,7264,6994],0); -ELEMENTS[63990] = Fluid3D([7578,6745,6826,6637],0); -ELEMENTS[63991] = Fluid3D([6826,6637,7264,7578],0); -ELEMENTS[63992] = Fluid3D([6826,7264,6994,7578],0); -ELEMENTS[63993] = Fluid3D([15985,16092,15523,16026],0); -ELEMENTS[63994] = Fluid3D([14517,14825,14817,15471],0); -ELEMENTS[63995] = Fluid3D([10619,11563,11513,12025],0); -ELEMENTS[63996] = Fluid3D([15774,16409,15670,15824],0); -ELEMENTS[63997] = Fluid3D([2725,2595,2497,2718],0); -ELEMENTS[63998] = Fluid3D([4280,4429,4769,4893],0); -ELEMENTS[63999] = Fluid3D([11110,10356,10529,10255],0); -ELEMENTS[64000] = Fluid3D([13189,12909,13404,12425],0); -ELEMENTS[64001] = Fluid3D([17439,17505,17815,17629],0); -ELEMENTS[64002] = Fluid3D([17815,17439,17629,17927],0); -ELEMENTS[64003] = Fluid3D([17215,17241,16954,17354],0); -ELEMENTS[64004] = Fluid3D([6523,6797,7107,7372],0); -ELEMENTS[64005] = Fluid3D([6271,6367,7181,6495],0); -ELEMENTS[64006] = Fluid3D([15263,14917,15565,15033],0); -ELEMENTS[64007] = Fluid3D([12691,13213,12856,13458],0); -ELEMENTS[64008] = Fluid3D([9963,9263,9591,9102],0); -ELEMENTS[64009] = Fluid3D([10548,11146,11365,11835],0); -ELEMENTS[64010] = Fluid3D([11146,11365,11835,11537],0); -ELEMENTS[64011] = Fluid3D([11835,11146,11537,11969],0); -ELEMENTS[64012] = Fluid3D([10548,11146,11835,11647],0); -ELEMENTS[64013] = Fluid3D([11146,11835,11647,11786],0); -ELEMENTS[64014] = Fluid3D([11146,11835,11786,11969],0); -ELEMENTS[64015] = Fluid3D([9616,9546,9102,8194],0); -ELEMENTS[64016] = Fluid3D([14233,13731,14340,13744],0); -ELEMENTS[64017] = Fluid3D([14340,14233,13744,14806],0); -ELEMENTS[64018] = Fluid3D([10408,9554,10795,9720],0); -ELEMENTS[64019] = Fluid3D([4406,4416,3962,4365],0); -ELEMENTS[64020] = Fluid3D([2339,2162,2146,2250],0); -ELEMENTS[64021] = Fluid3D([4297,4122,3886,4308],0); -ELEMENTS[64022] = Fluid3D([4297,4122,4308,4357],0); -ELEMENTS[64023] = Fluid3D([9723,8858,9392,9177],0); -ELEMENTS[64024] = Fluid3D([18532,18585,18503,18579],0); -ELEMENTS[64025] = Fluid3D([12435,11813,13108,13056],0); -ELEMENTS[64026] = Fluid3D([13108,12435,13056,13360],0); -ELEMENTS[64027] = Fluid3D([13149,14162,13807,13336],0); -ELEMENTS[64028] = Fluid3D([8522,8260,9337,9505],0); -ELEMENTS[64029] = Fluid3D([18678,18689,18697,18694],0); -ELEMENTS[64030] = Fluid3D([18478,18351,18371,18302],0); -ELEMENTS[64031] = Fluid3D([16221,16238,15986,15651],0); -ELEMENTS[64032] = Fluid3D([11088,11697,12373,12119],0); -ELEMENTS[64033] = Fluid3D([15051,15808,15592,15305],0); -ELEMENTS[64034] = Fluid3D([14278,14119,13770,13434],0); -ELEMENTS[64035] = Fluid3D([18664,18651,18689,18677],0); -ELEMENTS[64036] = Fluid3D([18664,18651,18677,18644],0); -ELEMENTS[64037] = Fluid3D([8846,8793,9152,7791],0); -ELEMENTS[64038] = Fluid3D([7734,7529,6714,7740],0); -ELEMENTS[64039] = Fluid3D([7734,7529,7740,8383],0); -ELEMENTS[64040] = Fluid3D([7734,7529,8383,8385],0); -ELEMENTS[64041] = Fluid3D([7740,7734,8383,8734],0); -ELEMENTS[64042] = Fluid3D([7734,8383,8734,8385],0); -ELEMENTS[64043] = Fluid3D([8383,8734,8385,9108],0); -ELEMENTS[64044] = Fluid3D([8383,8734,9108,7740],0); -ELEMENTS[64045] = Fluid3D([8385,8383,9108,8347],0); -ELEMENTS[64046] = Fluid3D([8383,9108,8347,7740],0); -ELEMENTS[64047] = Fluid3D([7529,8383,8385,8347],0); -ELEMENTS[64048] = Fluid3D([8347,8383,7740,7529],0); -ELEMENTS[64049] = Fluid3D([14591,14649,15169,14502],0); -ELEMENTS[64050] = Fluid3D([4872,5410,5200,4583],0); -ELEMENTS[64051] = Fluid3D([10670,11109,10235,11257],0); -ELEMENTS[64052] = Fluid3D([10670,11109,11257,11972],0); -ELEMENTS[64053] = Fluid3D([10235,10670,11257,10540],0); -ELEMENTS[64054] = Fluid3D([10670,11257,10540,11807],0); -ELEMENTS[64055] = Fluid3D([10670,11257,11807,11972],0); -ELEMENTS[64056] = Fluid3D([11257,11807,11972,12218],0); -ELEMENTS[64057] = Fluid3D([15023,14596,15578,15053],0); -ELEMENTS[64058] = Fluid3D([17715,17484,17915,17908],0); -ELEMENTS[64059] = Fluid3D([7856,7932,7919,8898],0); -ELEMENTS[64060] = Fluid3D([12855,12752,12583,13245],0); -ELEMENTS[64061] = Fluid3D([12040,11986,11048,11560],0); -ELEMENTS[64062] = Fluid3D([12145,12178,11987,13158],0); -ELEMENTS[64063] = Fluid3D([12261,11121,11429,11489],0); -ELEMENTS[64064] = Fluid3D([9279,8543,9429,9247],0); -ELEMENTS[64065] = Fluid3D([8543,9429,9247,8428],0); -ELEMENTS[64066] = Fluid3D([13817,14079,14550,14198],0); -ELEMENTS[64067] = Fluid3D([2354,2341,2074,2338],0); -ELEMENTS[64068] = Fluid3D([12358,12986,12619,11692],0); -ELEMENTS[64069] = Fluid3D([16152,16050,15718,16310],0); -ELEMENTS[64070] = Fluid3D([14790,15241,14618,14696],0); -ELEMENTS[64071] = Fluid3D([14618,14790,14696,14023],0); -ELEMENTS[64072] = Fluid3D([15241,14618,14696,15556],0); -ELEMENTS[64073] = Fluid3D([9780,9965,9773,10817],0); -ELEMENTS[64074] = Fluid3D([12333,13192,12732,12967],0); -ELEMENTS[64075] = Fluid3D([14241,14588,14381,14711],0); -ELEMENTS[64076] = Fluid3D([17812,18127,17879,17840],0); -ELEMENTS[64077] = Fluid3D([11229,11174,10089,10551],0); -ELEMENTS[64078] = Fluid3D([14489,13864,14070,13743],0); -ELEMENTS[64079] = Fluid3D([12427,13024,11707,11979],0); -ELEMENTS[64080] = Fluid3D([11707,12427,11979,11716],0); -ELEMENTS[64081] = Fluid3D([17692,17613,17456,17373],0); -ELEMENTS[64082] = Fluid3D([3339,3698,3504,3595],0); -ELEMENTS[64083] = Fluid3D([4064,4489,4305,4802],0); -ELEMENTS[64084] = Fluid3D([17309,17546,17216,17501],0); -ELEMENTS[64085] = Fluid3D([3137,3511,3144,3009],0); -ELEMENTS[64086] = Fluid3D([6405,6590,7069,6373],0); -ELEMENTS[64087] = Fluid3D([4244,4334,4527,4935],0); -ELEMENTS[64088] = Fluid3D([16473,16079,16232,16472],0); -ELEMENTS[64089] = Fluid3D([7238,6886,7814,7477],0); -ELEMENTS[64090] = Fluid3D([14242,14187,13649,14220],0); -ELEMENTS[64091] = Fluid3D([17808,17885,18120,17660],0); -ELEMENTS[64092] = Fluid3D([11798,12175,12101,10967],0); -ELEMENTS[64093] = Fluid3D([7188,6805,7112,7353],0); -ELEMENTS[64094] = Fluid3D([7188,6805,7353,7867],0); -ELEMENTS[64095] = Fluid3D([15136,14733,14741,14693],0); -ELEMENTS[64096] = Fluid3D([15136,14733,14693,15131],0); -ELEMENTS[64097] = Fluid3D([14741,15136,14693,14561],0); -ELEMENTS[64098] = Fluid3D([15136,14693,14561,15015],0); -ELEMENTS[64099] = Fluid3D([11381,11726,10722,11787],0); -ELEMENTS[64100] = Fluid3D([11381,11726,11787,12204],0); -ELEMENTS[64101] = Fluid3D([11787,11381,12204,12570],0); -ELEMENTS[64102] = Fluid3D([11787,11381,12570,11289],0); -ELEMENTS[64103] = Fluid3D([11787,11381,11289,10349],0); -ELEMENTS[64104] = Fluid3D([5932,6273,6258,5562],0); -ELEMENTS[64105] = Fluid3D([7015,6908,6296,6067],0); -ELEMENTS[64106] = Fluid3D([11743,12190,11030,11921],0); -ELEMENTS[64107] = Fluid3D([9571,9589,10255,10674],0); -ELEMENTS[64108] = Fluid3D([2196,2071,1967,1992],0); -ELEMENTS[64109] = Fluid3D([7226,7883,7052,6951],0); -ELEMENTS[64110] = Fluid3D([11920,11713,11162,11332],0); -ELEMENTS[64111] = Fluid3D([11999,11375,11995,12684],0); -ELEMENTS[64112] = Fluid3D([8364,9235,9242,9341],0); -ELEMENTS[64113] = Fluid3D([7265,6696,6770,6709],0); -ELEMENTS[64114] = Fluid3D([14286,13485,14315,13720],0); -ELEMENTS[64115] = Fluid3D([9299,8728,9375,9554],0); -ELEMENTS[64116] = Fluid3D([9299,8728,9554,8835],0); -ELEMENTS[64117] = Fluid3D([13295,14015,14618,14023],0); -ELEMENTS[64118] = Fluid3D([1728,1752,1727,1660],0); -ELEMENTS[64119] = Fluid3D([1752,1727,1660,1659],0); -ELEMENTS[64120] = Fluid3D([7615,7666,7866,6736],0); -ELEMENTS[64121] = Fluid3D([17016,17050,16700,16660],0); -ELEMENTS[64122] = Fluid3D([5377,5463,5130,4666],0); -ELEMENTS[64123] = Fluid3D([11481,10442,10210,11148],0); -ELEMENTS[64124] = Fluid3D([5929,5264,5058,5472],0); -ELEMENTS[64125] = Fluid3D([12376,12614,12988,13462],0); -ELEMENTS[64126] = Fluid3D([18335,18331,18082,18380],0); -ELEMENTS[64127] = Fluid3D([2705,2475,2854,2641],0); -ELEMENTS[64128] = Fluid3D([2705,2475,2641,2582],0); -ELEMENTS[64129] = Fluid3D([2641,2705,2582,3037],0); -ELEMENTS[64130] = Fluid3D([2475,2854,2641,2381],0); -ELEMENTS[64131] = Fluid3D([2641,2475,2381,2582],0); -ELEMENTS[64132] = Fluid3D([2582,2641,3037,2735],0); -ELEMENTS[64133] = Fluid3D([2582,2641,2735,2451],0); -ELEMENTS[64134] = Fluid3D([2854,2705,2641,3037],0); -ELEMENTS[64135] = Fluid3D([4992,5069,5234,4339],0); -ELEMENTS[64136] = Fluid3D([8982,8728,9703,8755],0); -ELEMENTS[64137] = Fluid3D([9649,8997,9990,9887],0); -ELEMENTS[64138] = Fluid3D([14560,14661,14214,13919],0); -ELEMENTS[64139] = Fluid3D([14560,14661,13919,14541],0); -ELEMENTS[64140] = Fluid3D([14214,14560,13919,13509],0); -ELEMENTS[64141] = Fluid3D([14214,14560,13509,14701],0); -ELEMENTS[64142] = Fluid3D([14214,14560,14701,15234],0); -ELEMENTS[64143] = Fluid3D([14560,14701,15234,14541],0); -ELEMENTS[64144] = Fluid3D([14560,13919,13509,14701],0); -ELEMENTS[64145] = Fluid3D([14560,13919,14701,14541],0); -ELEMENTS[64146] = Fluid3D([4315,3928,4287,4365],0); -ELEMENTS[64147] = Fluid3D([15627,16098,16125,15697],0); -ELEMENTS[64148] = Fluid3D([10738,10404,9920,9690],0); -ELEMENTS[64149] = Fluid3D([5036,4906,5531,5520],0); -ELEMENTS[64150] = Fluid3D([8759,7873,7867,8055],0); -ELEMENTS[64151] = Fluid3D([2804,2860,2538,2636],0); -ELEMENTS[64152] = Fluid3D([2860,2538,2636,2680],0); -ELEMENTS[64153] = Fluid3D([2538,2804,2636,2550],0); -ELEMENTS[64154] = Fluid3D([2636,2538,2550,2384],0); -ELEMENTS[64155] = Fluid3D([2636,2538,2384,2680],0); -ELEMENTS[64156] = Fluid3D([2636,2860,2680,3156],0); -ELEMENTS[64157] = Fluid3D([2384,2636,2680,2425],0); -ELEMENTS[64158] = Fluid3D([2636,2680,2425,2846],0); -ELEMENTS[64159] = Fluid3D([2636,2680,2846,3156],0); -ELEMENTS[64160] = Fluid3D([4393,4208,4225,4886],0); -ELEMENTS[64161] = Fluid3D([6170,6183,5473,5704],0); -ELEMENTS[64162] = Fluid3D([7040,6788,6879,6020],0); -ELEMENTS[64163] = Fluid3D([8174,7832,8299,7344],0); -ELEMENTS[64164] = Fluid3D([8299,8174,7344,7326],0); -ELEMENTS[64165] = Fluid3D([7344,8299,7326,8257],0); -ELEMENTS[64166] = Fluid3D([8174,7344,7326,7832],0); -ELEMENTS[64167] = Fluid3D([1999,1840,2032,1911],0); -ELEMENTS[64168] = Fluid3D([17432,17731,17236,17532],0); -ELEMENTS[64169] = Fluid3D([17432,17731,17532,17587],0); -ELEMENTS[64170] = Fluid3D([17432,17731,17587,17747],0); -ELEMENTS[64171] = Fluid3D([17432,17731,17747,17671],0); -ELEMENTS[64172] = Fluid3D([11949,12751,11897,11272],0); -ELEMENTS[64173] = Fluid3D([16108,16744,16363,16336],0); -ELEMENTS[64174] = Fluid3D([13930,14218,14258,13435],0); -ELEMENTS[64175] = Fluid3D([17244,17433,17432,17671],0); -ELEMENTS[64176] = Fluid3D([18608,18485,18573,18532],0); -ELEMENTS[64177] = Fluid3D([18573,18608,18532,18632],0); -ELEMENTS[64178] = Fluid3D([18608,18485,18532,18585],0); -ELEMENTS[64179] = Fluid3D([18573,18608,18632,18629],0); -ELEMENTS[64180] = Fluid3D([18573,18608,18629,18518],0); -ELEMENTS[64181] = Fluid3D([18532,18573,18632,18579],0); -ELEMENTS[64182] = Fluid3D([5878,5256,5346,5542],0); -ELEMENTS[64183] = Fluid3D([14727,14428,15037,15055],0); -ELEMENTS[64184] = Fluid3D([7030,6768,7096,6351],0); -ELEMENTS[64185] = Fluid3D([7096,7030,6351,6097],0); -ELEMENTS[64186] = Fluid3D([7030,6768,6351,6097],0); -ELEMENTS[64187] = Fluid3D([18545,18436,18577,18547],0); -ELEMENTS[64188] = Fluid3D([6519,6512,6000,5766],0); -ELEMENTS[64189] = Fluid3D([13916,13835,13108,13952],0); -ELEMENTS[64190] = Fluid3D([3018,3140,2989,2699],0); -ELEMENTS[64191] = Fluid3D([13809,14268,13232,14231],0); -ELEMENTS[64192] = Fluid3D([3388,3643,3336,3704],0); -ELEMENTS[64193] = Fluid3D([3388,3643,3704,3913],0); -ELEMENTS[64194] = Fluid3D([3336,3388,3704,3497],0); -ELEMENTS[64195] = Fluid3D([3388,3704,3497,3913],0); -ELEMENTS[64196] = Fluid3D([3763,3393,3356,3460],0); -ELEMENTS[64197] = Fluid3D([12789,12495,11837,12315],0); -ELEMENTS[64198] = Fluid3D([17605,17760,17861,18073],0); -ELEMENTS[64199] = Fluid3D([12936,12715,13091,13905],0); -ELEMENTS[64200] = Fluid3D([13147,12670,13550,13564],0); -ELEMENTS[64201] = Fluid3D([7983,7351,7966,8699],0); -ELEMENTS[64202] = Fluid3D([16659,16980,16789,17180],0); -ELEMENTS[64203] = Fluid3D([16789,16659,17180,16672],0); -ELEMENTS[64204] = Fluid3D([4318,4424,3863,3856],0); -ELEMENTS[64205] = Fluid3D([1625,1664,1759,1613],0); -ELEMENTS[64206] = Fluid3D([1625,1664,1613,1546],0); -ELEMENTS[64207] = Fluid3D([18015,17874,18136,18266],0); -ELEMENTS[64208] = Fluid3D([13060,13401,13822,13263],0); -ELEMENTS[64209] = Fluid3D([7498,6995,7996,7218],0); -ELEMENTS[64210] = Fluid3D([13903,13542,14516,13775],0); -ELEMENTS[64211] = Fluid3D([3544,3525,3321,3734],0); -ELEMENTS[64212] = Fluid3D([12359,13008,12643,12379],0); -ELEMENTS[64213] = Fluid3D([3666,3331,3530,3376],0); -ELEMENTS[64214] = Fluid3D([9129,8284,8426,9215],0); -ELEMENTS[64215] = Fluid3D([7143,8002,7351,8012],0); -ELEMENTS[64216] = Fluid3D([8002,7351,8012,8699],0); -ELEMENTS[64217] = Fluid3D([8012,8002,8699,8151],0); -ELEMENTS[64218] = Fluid3D([8012,8002,8151,7143],0); -ELEMENTS[64219] = Fluid3D([7351,8012,8699,7983],0); -ELEMENTS[64220] = Fluid3D([7351,8012,7983,7539],0); -ELEMENTS[64221] = Fluid3D([7351,8012,7539,7143],0); -ELEMENTS[64222] = Fluid3D([11514,10761,11002,12032],0); -ELEMENTS[64223] = Fluid3D([7788,8054,7407,7540],0); -ELEMENTS[64224] = Fluid3D([17006,17052,17374,16745],0); -ELEMENTS[64225] = Fluid3D([15350,15580,14821,14942],0); -ELEMENTS[64226] = Fluid3D([15350,15580,14942,15462],0); -ELEMENTS[64227] = Fluid3D([14453,15109,14735,15246],0); -ELEMENTS[64228] = Fluid3D([6347,6194,6442,7213],0); -ELEMENTS[64229] = Fluid3D([15161,14293,14272,14855],0); -ELEMENTS[64230] = Fluid3D([16038,16287,16046,15638],0); -ELEMENTS[64231] = Fluid3D([5078,5107,5103,5657],0); -ELEMENTS[64232] = Fluid3D([5103,5078,5657,5364],0); -ELEMENTS[64233] = Fluid3D([10501,10089,10551,9546],0); -ELEMENTS[64234] = Fluid3D([13614,13659,13102,13790],0); -ELEMENTS[64235] = Fluid3D([9316,9535,10109,8721],0); -ELEMENTS[64236] = Fluid3D([16442,16639,16470,16154],0); -ELEMENTS[64237] = Fluid3D([16639,16470,16154,16258],0); -ELEMENTS[64238] = Fluid3D([16470,16154,16258,15676],0); -ELEMENTS[64239] = Fluid3D([16154,16258,15676,15654],0); -ELEMENTS[64240] = Fluid3D([16154,16639,16258,16374],0); -ELEMENTS[64241] = Fluid3D([16258,16154,16374,15654],0); -ELEMENTS[64242] = Fluid3D([3725,3867,4138,3693],0); -ELEMENTS[64243] = Fluid3D([11234,10796,11947,11196],0); -ELEMENTS[64244] = Fluid3D([9752,9994,10238,11254],0); -ELEMENTS[64245] = Fluid3D([10382,9540,9314,9966],0); -ELEMENTS[64246] = Fluid3D([17952,18031,17868,18075],0); -ELEMENTS[64247] = Fluid3D([14406,14875,15211,14699],0); -ELEMENTS[64248] = Fluid3D([4761,5358,4637,4958],0); -ELEMENTS[64249] = Fluid3D([4637,4761,4958,4624],0); -ELEMENTS[64250] = Fluid3D([4761,4958,4624,5358],0); -ELEMENTS[64251] = Fluid3D([12984,13686,13765,13271],0); -ELEMENTS[64252] = Fluid3D([12674,12354,11549,12047],0); -ELEMENTS[64253] = Fluid3D([11549,12674,12047,12091],0); -ELEMENTS[64254] = Fluid3D([12674,12047,12091,12824],0); -ELEMENTS[64255] = Fluid3D([12047,11549,12091,11554],0); -ELEMENTS[64256] = Fluid3D([12091,12674,12824,12330],0); -ELEMENTS[64257] = Fluid3D([12824,12091,12330,12239],0); -ELEMENTS[64258] = Fluid3D([12824,12091,12239,11554],0); -ELEMENTS[64259] = Fluid3D([12824,12091,11554,12481],0); -ELEMENTS[64260] = Fluid3D([12091,12047,11554,12481],0); -ELEMENTS[64261] = Fluid3D([11549,12674,12091,12330],0); -ELEMENTS[64262] = Fluid3D([7284,6888,6946,7818],0); -ELEMENTS[64263] = Fluid3D([3023,2831,3143,3128],0); -ELEMENTS[64264] = Fluid3D([6441,6335,5751,6164],0); -ELEMENTS[64265] = Fluid3D([12261,11567,12186,11489],0); -ELEMENTS[64266] = Fluid3D([5607,5216,4885,5065],0); -ELEMENTS[64267] = Fluid3D([7466,7653,6711,7359],0); -ELEMENTS[64268] = Fluid3D([6711,7466,7359,6842],0); -ELEMENTS[64269] = Fluid3D([13034,13076,12468,12128],0); -ELEMENTS[64270] = Fluid3D([8326,8227,7409,8515],0); -ELEMENTS[64271] = Fluid3D([11490,11371,11884,10994],0); -ELEMENTS[64272] = Fluid3D([4526,3875,4087,3958],0); -ELEMENTS[64273] = Fluid3D([16475,16188,16355,15749],0); -ELEMENTS[64274] = Fluid3D([15698,15934,15654,15030],0); -ELEMENTS[64275] = Fluid3D([16366,16443,16464,17106],0); -ELEMENTS[64276] = Fluid3D([4153,4468,4832,4425],0); -ELEMENTS[64277] = Fluid3D([8947,8945,8291,8283],0); -ELEMENTS[64278] = Fluid3D([8947,8945,8283,9120],0); -ELEMENTS[64279] = Fluid3D([12763,11965,13036,12639],0); -ELEMENTS[64280] = Fluid3D([9615,9591,10413,10170],0); -ELEMENTS[64281] = Fluid3D([11922,11656,11233,10634],0); -ELEMENTS[64282] = Fluid3D([11233,11922,10634,11852],0); -ELEMENTS[64283] = Fluid3D([11233,11922,11852,11861],0); -ELEMENTS[64284] = Fluid3D([11233,11922,11861,12237],0); -ELEMENTS[64285] = Fluid3D([6523,6566,5844,5981],0); -ELEMENTS[64286] = Fluid3D([12037,12848,13190,12803],0); -ELEMENTS[64287] = Fluid3D([16338,16425,16431,16967],0); -ELEMENTS[64288] = Fluid3D([15928,16264,16360,16189],0); -ELEMENTS[64289] = Fluid3D([12178,12320,12805,12182],0); -ELEMENTS[64290] = Fluid3D([2899,2858,2546,2517],0); -ELEMENTS[64291] = Fluid3D([4070,3960,4300,3692],0); -ELEMENTS[64292] = Fluid3D([2350,2409,2550,2701],0); -ELEMENTS[64293] = Fluid3D([18635,18609,18575,18522],0); -ELEMENTS[64294] = Fluid3D([18575,18635,18522,18566],0); -ELEMENTS[64295] = Fluid3D([18522,18575,18566,18527],0); -ELEMENTS[64296] = Fluid3D([18522,18575,18527,18375],0); -ELEMENTS[64297] = Fluid3D([18609,18575,18522,18533],0); -ELEMENTS[64298] = Fluid3D([18575,18522,18533,18417],0); -ELEMENTS[64299] = Fluid3D([18522,18575,18375,18417],0); -ELEMENTS[64300] = Fluid3D([6177,5635,6137,6892],0); -ELEMENTS[64301] = Fluid3D([13232,12486,12351,12373],0); -ELEMENTS[64302] = Fluid3D([6163,6527,5704,6298],0); -ELEMENTS[64303] = Fluid3D([15550,15565,15033,15757],0); -ELEMENTS[64304] = Fluid3D([15145,14421,14866,15016],0); -ELEMENTS[64305] = Fluid3D([14866,15145,15016,15616],0); -ELEMENTS[64306] = Fluid3D([15016,14866,15616,15341],0); -ELEMENTS[64307] = Fluid3D([15016,14866,15341,14454],0); -ELEMENTS[64308] = Fluid3D([14421,14866,15016,14454],0); -ELEMENTS[64309] = Fluid3D([1933,1955,1906,2179],0); -ELEMENTS[64310] = Fluid3D([4861,4426,5050,4699],0); -ELEMENTS[64311] = Fluid3D([13444,13959,14106,12928],0); -ELEMENTS[64312] = Fluid3D([13781,14239,14669,14853],0); -ELEMENTS[64313] = Fluid3D([10015,10122,9376,10326],0); -ELEMENTS[64314] = Fluid3D([6810,7071,7812,7728],0); -ELEMENTS[64315] = Fluid3D([16735,16383,16814,16150],0); -ELEMENTS[64316] = Fluid3D([4285,3831,4617,3894],0); -ELEMENTS[64317] = Fluid3D([8638,8520,7425,8046],0); -ELEMENTS[64318] = Fluid3D([4334,4278,4775,4241],0); -ELEMENTS[64319] = Fluid3D([13355,13708,13221,12607],0); -ELEMENTS[64320] = Fluid3D([10524,10681,9906,11134],0); -ELEMENTS[64321] = Fluid3D([15279,14638,15025,15266],0); -ELEMENTS[64322] = Fluid3D([11344,10794,11074,10980],0); -ELEMENTS[64323] = Fluid3D([12477,12816,11622,11613],0); -ELEMENTS[64324] = Fluid3D([15186,15100,15649,15438],0); -ELEMENTS[64325] = Fluid3D([6421,6824,7198,6162],0); -ELEMENTS[64326] = Fluid3D([5109,4722,5115,4363],0); -ELEMENTS[64327] = Fluid3D([6140,6982,6116,7244],0); -ELEMENTS[64328] = Fluid3D([14220,14231,14906,15190],0); -ELEMENTS[64329] = Fluid3D([13926,12924,13774,13307],0); -ELEMENTS[64330] = Fluid3D([6351,6330,6097,5455],0); -ELEMENTS[64331] = Fluid3D([10430,9662,9966,9314],0); -ELEMENTS[64332] = Fluid3D([10430,9662,9314,9133],0); -ELEMENTS[64333] = Fluid3D([9662,9314,9133,9447],0); -ELEMENTS[64334] = Fluid3D([9662,9314,9447,9966],0); -ELEMENTS[64335] = Fluid3D([9447,9662,9966,10287],0); -ELEMENTS[64336] = Fluid3D([9314,9447,9966,8631],0); -ELEMENTS[64337] = Fluid3D([12300,12616,11964,12965],0); -ELEMENTS[64338] = Fluid3D([4940,4514,4757,5292],0); -ELEMENTS[64339] = Fluid3D([13407,13564,12670,13147],0); -ELEMENTS[64340] = Fluid3D([10932,10479,9962,11164],0); -ELEMENTS[64341] = Fluid3D([15782,15746,15050,15298],0); -ELEMENTS[64342] = Fluid3D([9475,9213,10263,10239],0); -ELEMENTS[64343] = Fluid3D([15836,15871,16147,16591],0); -ELEMENTS[64344] = Fluid3D([16862,17299,16693,17040],0); -ELEMENTS[64345] = Fluid3D([4059,3776,3713,3468],0); -ELEMENTS[64346] = Fluid3D([3762,3754,3334,3905],0); -ELEMENTS[64347] = Fluid3D([17470,17515,17014,17283],0); -ELEMENTS[64348] = Fluid3D([16487,16838,16791,17104],0); -ELEMENTS[64349] = Fluid3D([16487,16838,17104,16968],0); -ELEMENTS[64350] = Fluid3D([16487,16838,16968,16263],0); -ELEMENTS[64351] = Fluid3D([8545,8189,8509,7542],0); -ELEMENTS[64352] = Fluid3D([17736,17526,17365,17327],0); -ELEMENTS[64353] = Fluid3D([4477,4939,4419,4804],0); -ELEMENTS[64354] = Fluid3D([12308,11723,11508,11401],0); -ELEMENTS[64355] = Fluid3D([9790,10552,9956,11105],0); -ELEMENTS[64356] = Fluid3D([14602,14433,14489,13609],0); -ELEMENTS[64357] = Fluid3D([14489,14602,13609,13743],0); -ELEMENTS[64358] = Fluid3D([14739,14859,15441,14941],0); -ELEMENTS[64359] = Fluid3D([1746,1931,1878,1818],0); -ELEMENTS[64360] = Fluid3D([17745,17465,17744,17340],0); -ELEMENTS[64361] = Fluid3D([3574,3227,3307,3023],0); -ELEMENTS[64362] = Fluid3D([7788,8494,8331,8378],0); -ELEMENTS[64363] = Fluid3D([6368,6761,7147,6251],0); -ELEMENTS[64364] = Fluid3D([7472,7610,7250,6302],0); -ELEMENTS[64365] = Fluid3D([5994,6768,6097,6351],0); -ELEMENTS[64366] = Fluid3D([5994,6768,6351,5858],0); -ELEMENTS[64367] = Fluid3D([6097,5994,6351,5858],0); -ELEMENTS[64368] = Fluid3D([2222,2152,2037,2009],0); -ELEMENTS[64369] = Fluid3D([2222,2152,2009,2200],0); -ELEMENTS[64370] = Fluid3D([2222,2152,2200,2326],0); -ELEMENTS[64371] = Fluid3D([2152,2200,2326,2171],0); -ELEMENTS[64372] = Fluid3D([2200,2326,2171,2061],0); -ELEMENTS[64373] = Fluid3D([2200,2326,2061,2210],0); -ELEMENTS[64374] = Fluid3D([2061,2200,2210,2032],0); -ELEMENTS[64375] = Fluid3D([6061,5520,5606,5531],0); -ELEMENTS[64376] = Fluid3D([13511,14255,13720,14286],0); -ELEMENTS[64377] = Fluid3D([6419,6387,7258,6944],0); -ELEMENTS[64378] = Fluid3D([2018,2047,2147,1933],0); -ELEMENTS[64379] = Fluid3D([17725,17548,17776,17531],0); -ELEMENTS[64380] = Fluid3D([7805,8276,7381,7309],0); -ELEMENTS[64381] = Fluid3D([12241,11875,11686,12972],0); -ELEMENTS[64382] = Fluid3D([13861,13655,14569,14140],0); -ELEMENTS[64383] = Fluid3D([15191,15798,15468,16220],0); -ELEMENTS[64384] = Fluid3D([15219,15223,14956,15490],0); -ELEMENTS[64385] = Fluid3D([5383,5035,5564,5220],0); -ELEMENTS[64386] = Fluid3D([12873,13342,12605,11795],0); -ELEMENTS[64387] = Fluid3D([8503,9413,8635,9260],0); -ELEMENTS[64388] = Fluid3D([18535,18516,18613,18518],0); -ELEMENTS[64389] = Fluid3D([6222,5609,5818,6308],0); -ELEMENTS[64390] = Fluid3D([18030,17892,17972,17854],0); -ELEMENTS[64391] = Fluid3D([18030,17892,17854,17791],0); -ELEMENTS[64392] = Fluid3D([17854,18030,17791,17972],0); -ELEMENTS[64393] = Fluid3D([17892,17854,17791,17591],0); -ELEMENTS[64394] = Fluid3D([17854,17791,17591,17638],0); -ELEMENTS[64395] = Fluid3D([17892,17854,17591,17638],0); -ELEMENTS[64396] = Fluid3D([17791,17854,17972,17638],0); -ELEMENTS[64397] = Fluid3D([17892,17972,17854,17638],0); -ELEMENTS[64398] = Fluid3D([17791,17892,17591,18030],0); -ELEMENTS[64399] = Fluid3D([17892,17591,18030,17816],0); -ELEMENTS[64400] = Fluid3D([9204,9051,8781,7914],0); -ELEMENTS[64401] = Fluid3D([13832,14453,14417,13629],0); -ELEMENTS[64402] = Fluid3D([11275,10845,10833,9710],0); -ELEMENTS[64403] = Fluid3D([5593,5321,4873,5379],0); -ELEMENTS[64404] = Fluid3D([13484,13298,13716,13140],0); -ELEMENTS[64405] = Fluid3D([7733,8297,8829,7661],0); -ELEMENTS[64406] = Fluid3D([4385,3914,4302,4047],0); -ELEMENTS[64407] = Fluid3D([16347,16436,15876,16386],0); -ELEMENTS[64408] = Fluid3D([11312,11515,11114,12022],0); -ELEMENTS[64409] = Fluid3D([5915,5465,5316,5615],0); -ELEMENTS[64410] = Fluid3D([12845,12619,12986,11692],0); -ELEMENTS[64411] = Fluid3D([3838,3557,3980,3881],0); -ELEMENTS[64412] = Fluid3D([5599,4997,5742,5099],0); -ELEMENTS[64413] = Fluid3D([10200,10110,9329,10369],0); -ELEMENTS[64414] = Fluid3D([8180,7477,7238,7814],0); -ELEMENTS[64415] = Fluid3D([3145,2981,2689,2890],0); -ELEMENTS[64416] = Fluid3D([2536,2817,2485,2527],0); -ELEMENTS[64417] = Fluid3D([5118,5018,5524,5805],0); -ELEMENTS[64418] = Fluid3D([9754,10051,10659,11382],0); -ELEMENTS[64419] = Fluid3D([4767,4638,4753,5276],0); -ELEMENTS[64420] = Fluid3D([4753,4767,5276,5089],0); -ELEMENTS[64421] = Fluid3D([5200,5410,5781,5283],0); -ELEMENTS[64422] = Fluid3D([16935,17232,17540,17045],0); -ELEMENTS[64423] = Fluid3D([3860,3890,3730,4269],0); -ELEMENTS[64424] = Fluid3D([3730,3860,4269,3916],0); -ELEMENTS[64425] = Fluid3D([18568,18553,18452,18370],0); -ELEMENTS[64426] = Fluid3D([2498,2674,2391,2518],0); -ELEMENTS[64427] = Fluid3D([5928,6726,6173,5848],0); -ELEMENTS[64428] = Fluid3D([14268,13715,13232,13780],0); -ELEMENTS[64429] = Fluid3D([10945,10794,9795,10435],0); -ELEMENTS[64430] = Fluid3D([5829,6625,6387,6296],0); -ELEMENTS[64431] = Fluid3D([6387,5829,6296,6063],0); -ELEMENTS[64432] = Fluid3D([9502,9551,10586,10774],0); -ELEMENTS[64433] = Fluid3D([4353,3877,4423,4054],0); -ELEMENTS[64434] = Fluid3D([14842,14375,14393,15144],0); -ELEMENTS[64435] = Fluid3D([17827,17977,17715,17895],0); -ELEMENTS[64436] = Fluid3D([15849,15442,15137,15814],0); -ELEMENTS[64437] = Fluid3D([16571,16110,16366,16821],0); -ELEMENTS[64438] = Fluid3D([15985,16356,16391,16749],0); -ELEMENTS[64439] = Fluid3D([11811,11436,10797,11466],0); -ELEMENTS[64440] = Fluid3D([7496,7634,8379,8161],0); -ELEMENTS[64441] = Fluid3D([6541,6404,7190,7078],0); -ELEMENTS[64442] = Fluid3D([6541,6404,7078,6000],0); -ELEMENTS[64443] = Fluid3D([6541,6404,6000,5748],0); -ELEMENTS[64444] = Fluid3D([18342,18275,18322,18461],0); -ELEMENTS[64445] = Fluid3D([2793,2493,2598,2770],0); -ELEMENTS[64446] = Fluid3D([5068,4478,4985,5282],0); -ELEMENTS[64447] = Fluid3D([4985,5068,5282,5433],0); -ELEMENTS[64448] = Fluid3D([17986,17924,18039,17779],0); -ELEMENTS[64449] = Fluid3D([16046,16435,16567,16831],0); -ELEMENTS[64450] = Fluid3D([17755,18057,18078,17821],0); -ELEMENTS[64451] = Fluid3D([11755,12585,12239,12633],0); -ELEMENTS[64452] = Fluid3D([6317,6532,7079,6631],0); -ELEMENTS[64453] = Fluid3D([6317,6532,6631,5853],0); -ELEMENTS[64454] = Fluid3D([9527,10054,10271,10830],0); -ELEMENTS[64455] = Fluid3D([4041,4156,4726,4522],0); -ELEMENTS[64456] = Fluid3D([14845,15243,15677,15020],0); -ELEMENTS[64457] = Fluid3D([5590,6091,6090,5969],0); -ELEMENTS[64458] = Fluid3D([18656,18648,18674,18692],0); -ELEMENTS[64459] = Fluid3D([7806,8205,7848,6919],0); -ELEMENTS[64460] = Fluid3D([6367,6112,6476,6495],0); -ELEMENTS[64461] = Fluid3D([18438,18324,18220,18288],0); -ELEMENTS[64462] = Fluid3D([8926,9818,8743,9351],0); -ELEMENTS[64463] = Fluid3D([8926,9818,9351,9573],0); -ELEMENTS[64464] = Fluid3D([11880,12512,11914,11646],0); -ELEMENTS[64465] = Fluid3D([14873,14786,15498,15133],0); -ELEMENTS[64466] = Fluid3D([13228,13506,12965,13997],0); -ELEMENTS[64467] = Fluid3D([3155,3103,2853,2830],0); -ELEMENTS[64468] = Fluid3D([3155,3103,2830,3138],0); -ELEMENTS[64469] = Fluid3D([2853,3155,2830,2788],0); -ELEMENTS[64470] = Fluid3D([3103,2853,2830,2852],0); -ELEMENTS[64471] = Fluid3D([2830,3103,2852,3138],0); -ELEMENTS[64472] = Fluid3D([12411,12851,11708,12694],0); -ELEMENTS[64473] = Fluid3D([11708,12411,12694,12093],0); -ELEMENTS[64474] = Fluid3D([11708,12411,12093,12804],0); -ELEMENTS[64475] = Fluid3D([12411,12093,12804,12694],0); -ELEMENTS[64476] = Fluid3D([5590,5212,5701,5595],0); -ELEMENTS[64477] = Fluid3D([10404,11099,10566,9690],0); -ELEMENTS[64478] = Fluid3D([5737,4990,5317,5121],0); -ELEMENTS[64479] = Fluid3D([10919,10825,10817,9780],0); -ELEMENTS[64480] = Fluid3D([10817,10919,9780,10845],0); -ELEMENTS[64481] = Fluid3D([10817,10919,10845,11673],0); -ELEMENTS[64482] = Fluid3D([10919,10845,11673,11958],0); -ELEMENTS[64483] = Fluid3D([12779,12409,11857,12149],0); -ELEMENTS[64484] = Fluid3D([4783,4912,5347,5355],0); -ELEMENTS[64485] = Fluid3D([14287,13599,13622,14381],0); -ELEMENTS[64486] = Fluid3D([2627,2368,2558,2568],0); -ELEMENTS[64487] = Fluid3D([15702,15477,16051,15747],0); -ELEMENTS[64488] = Fluid3D([15477,16051,15747,15694],0); -ELEMENTS[64489] = Fluid3D([16051,15747,15694,16258],0); -ELEMENTS[64490] = Fluid3D([15477,16051,15694,15805],0); -ELEMENTS[64491] = Fluid3D([16051,15702,15747,16158],0); -ELEMENTS[64492] = Fluid3D([15747,15477,15694,15396],0); -ELEMENTS[64493] = Fluid3D([15694,15747,15396,15676],0); -ELEMENTS[64494] = Fluid3D([15396,15694,15676,16126],0); -ELEMENTS[64495] = Fluid3D([15396,15694,16126,15805],0); -ELEMENTS[64496] = Fluid3D([15396,15694,15805,15402],0); -ELEMENTS[64497] = Fluid3D([15694,16126,15805,16051],0); -ELEMENTS[64498] = Fluid3D([15694,16126,16051,16258],0); -ELEMENTS[64499] = Fluid3D([15694,15805,15402,15477],0); -ELEMENTS[64500] = Fluid3D([15477,15694,15396,15402],0); -ELEMENTS[64501] = Fluid3D([15694,16126,16258,15676],0); -ELEMENTS[64502] = Fluid3D([4019,3635,3658,4069],0); -ELEMENTS[64503] = Fluid3D([5617,5969,6090,6234],0); -ELEMENTS[64504] = Fluid3D([8514,9441,9668,9334],0); -ELEMENTS[64505] = Fluid3D([14458,13970,14301,13503],0); -ELEMENTS[64506] = Fluid3D([5236,5441,4745,5574],0); -ELEMENTS[64507] = Fluid3D([9910,10256,10218,9456],0); -ELEMENTS[64508] = Fluid3D([16318,16284,16335,15692],0); -ELEMENTS[64509] = Fluid3D([15381,15730,16084,16259],0); -ELEMENTS[64510] = Fluid3D([7093,7454,7662,7538],0); -ELEMENTS[64511] = Fluid3D([4587,4778,5099,5195],0); -ELEMENTS[64512] = Fluid3D([13625,12846,13393,13554],0); -ELEMENTS[64513] = Fluid3D([13058,12804,12629,12093],0); -ELEMENTS[64514] = Fluid3D([13058,12804,12093,12694],0); -ELEMENTS[64515] = Fluid3D([6447,6283,5805,5476],0); -ELEMENTS[64516] = Fluid3D([10357,9466,10709,9793],0); -ELEMENTS[64517] = Fluid3D([5773,5881,5153,5841],0); -ELEMENTS[64518] = Fluid3D([11377,11551,10531,11159],0); -ELEMENTS[64519] = Fluid3D([16471,16533,16975,16699],0); -ELEMENTS[64520] = Fluid3D([6958,6661,6901,5978],0); -ELEMENTS[64521] = Fluid3D([3074,3182,3327,3730],0); -ELEMENTS[64522] = Fluid3D([14435,14370,14331,15142],0); -ELEMENTS[64523] = Fluid3D([6742,6977,6044,6766],0); -ELEMENTS[64524] = Fluid3D([12613,12615,13014,13784],0); -ELEMENTS[64525] = Fluid3D([18680,18650,18625,18678],0); -ELEMENTS[64526] = Fluid3D([4004,3820,4255,3893],0); -ELEMENTS[64527] = Fluid3D([13341,12759,12304,12676],0); -ELEMENTS[64528] = Fluid3D([16637,16625,17196,17115],0); -ELEMENTS[64529] = Fluid3D([2993,3425,3159,3049],0); -ELEMENTS[64530] = Fluid3D([3159,2993,3049,2710],0); -ELEMENTS[64531] = Fluid3D([2993,3049,2710,3128],0); -ELEMENTS[64532] = Fluid3D([3425,3159,3049,3360],0); -ELEMENTS[64533] = Fluid3D([2993,3425,3049,3403],0); -ELEMENTS[64534] = Fluid3D([2993,3049,3128,3403],0); -ELEMENTS[64535] = Fluid3D([3159,3049,3360,3292],0); -ELEMENTS[64536] = Fluid3D([3159,3049,3292,2962],0); -ELEMENTS[64537] = Fluid3D([3049,3159,2710,2962],0); -ELEMENTS[64538] = Fluid3D([7594,8032,8426,7762],0); -ELEMENTS[64539] = Fluid3D([2135,1972,1966,2081],0); -ELEMENTS[64540] = Fluid3D([18278,18336,18302,18437],0); -ELEMENTS[64541] = Fluid3D([4577,4479,4644,5139],0); -ELEMENTS[64542] = Fluid3D([7668,6824,7225,7728],0); -ELEMENTS[64543] = Fluid3D([13777,13704,14545,14373],0); -ELEMENTS[64544] = Fluid3D([2717,3066,2813,2605],0); -ELEMENTS[64545] = Fluid3D([2798,2556,2366,2567],0); -ELEMENTS[64546] = Fluid3D([16392,16027,15891,16261],0); -ELEMENTS[64547] = Fluid3D([15891,16392,16261,16621],0); -ELEMENTS[64548] = Fluid3D([14057,14635,14072,13642],0); -ELEMENTS[64549] = Fluid3D([9014,8645,9135,8509],0); -ELEMENTS[64550] = Fluid3D([8349,7744,8675,8853],0); -ELEMENTS[64551] = Fluid3D([11063,10858,11215,9724],0); -ELEMENTS[64552] = Fluid3D([13409,13646,14328,13865],0); -ELEMENTS[64553] = Fluid3D([14585,14010,15099,14462],0); -ELEMENTS[64554] = Fluid3D([10372,10457,11216,11118],0); -ELEMENTS[64555] = Fluid3D([10604,9866,9313,10421],0); -ELEMENTS[64556] = Fluid3D([11501,12036,12238,11014],0); -ELEMENTS[64557] = Fluid3D([18326,18314,18183,18129],0); -ELEMENTS[64558] = Fluid3D([18183,18326,18129,18410],0); -ELEMENTS[64559] = Fluid3D([7911,7860,7154,8021],0); -ELEMENTS[64560] = Fluid3D([5418,6087,5476,5914],0); -ELEMENTS[64561] = Fluid3D([3919,4165,3818,3603],0); -ELEMENTS[64562] = Fluid3D([16498,16132,16381,16939],0); -ELEMENTS[64563] = Fluid3D([4751,5116,4991,5144],0); -ELEMENTS[64564] = Fluid3D([5733,5622,5853,6317],0); -ELEMENTS[64565] = Fluid3D([5733,5622,6317,6153],0); -ELEMENTS[64566] = Fluid3D([13754,13943,12922,13177],0); -ELEMENTS[64567] = Fluid3D([12389,12222,11975,11377],0); -ELEMENTS[64568] = Fluid3D([12389,12222,11377,11782],0); -ELEMENTS[64569] = Fluid3D([11826,11296,12225,11291],0); -ELEMENTS[64570] = Fluid3D([11296,12225,11291,12143],0); -ELEMENTS[64571] = Fluid3D([5064,4772,4436,4802],0); -ELEMENTS[64572] = Fluid3D([5064,4772,4802,5511],0); -ELEMENTS[64573] = Fluid3D([4772,4802,5511,5218],0); -ELEMENTS[64574] = Fluid3D([7478,7267,8201,7652],0); -ELEMENTS[64575] = Fluid3D([12106,12375,13151,12025],0); -ELEMENTS[64576] = Fluid3D([12106,12375,12025,11513],0); -ELEMENTS[64577] = Fluid3D([15158,14611,14557,14699],0); -ELEMENTS[64578] = Fluid3D([6156,5985,5508,5666],0); -ELEMENTS[64579] = Fluid3D([6156,5985,5666,6718],0); -ELEMENTS[64580] = Fluid3D([5508,6156,5666,5506],0); -ELEMENTS[64581] = Fluid3D([6156,5666,5506,6341],0); -ELEMENTS[64582] = Fluid3D([5985,5508,5666,5592],0); -ELEMENTS[64583] = Fluid3D([5985,5508,5592,5555],0); -ELEMENTS[64584] = Fluid3D([5592,5985,5555,6298],0); -ELEMENTS[64585] = Fluid3D([5508,5592,5555,4994],0); -ELEMENTS[64586] = Fluid3D([5666,5985,5592,5368],0); -ELEMENTS[64587] = Fluid3D([5666,5985,5368,5719],0); -ELEMENTS[64588] = Fluid3D([5368,5666,5719,5490],0); -ELEMENTS[64589] = Fluid3D([5368,5666,5490,5506],0); -ELEMENTS[64590] = Fluid3D([5368,5666,5506,5097],0); -ELEMENTS[64591] = Fluid3D([5666,5490,5506,6113],0); -ELEMENTS[64592] = Fluid3D([5506,5666,6113,6341],0); -ELEMENTS[64593] = Fluid3D([5368,5666,5097,5508],0); -ELEMENTS[64594] = Fluid3D([5666,5097,5508,5506],0); -ELEMENTS[64595] = Fluid3D([5368,5666,5508,5592],0); -ELEMENTS[64596] = Fluid3D([10558,9556,9904,10284],0); -ELEMENTS[64597] = Fluid3D([17653,17912,17592,17586],0); -ELEMENTS[64598] = Fluid3D([17592,17653,17586,17212],0); -ELEMENTS[64599] = Fluid3D([6514,7104,6254,6099],0); -ELEMENTS[64600] = Fluid3D([9317,8998,9682,9788],0); -ELEMENTS[64601] = Fluid3D([3938,4309,4397,3838],0); -ELEMENTS[64602] = Fluid3D([11791,12308,12987,11692],0); -ELEMENTS[64603] = Fluid3D([3419,3842,3839,3794],0); -ELEMENTS[64604] = Fluid3D([3421,3807,3688,3829],0); -ELEMENTS[64605] = Fluid3D([4958,5192,5634,5358],0); -ELEMENTS[64606] = Fluid3D([10530,10676,10428,11770],0); -ELEMENTS[64607] = Fluid3D([10268,10071,11119,11278],0); -ELEMENTS[64608] = Fluid3D([11671,10830,10543,11450],0); -ELEMENTS[64609] = Fluid3D([15177,14728,14594,14416],0); -ELEMENTS[64610] = Fluid3D([17253,17737,17692,17535],0); -ELEMENTS[64611] = Fluid3D([17737,17692,17535,17746],0); -ELEMENTS[64612] = Fluid3D([10882,10652,10981,9747],0); -ELEMENTS[64613] = Fluid3D([16105,16044,16454,16541],0); -ELEMENTS[64614] = Fluid3D([16105,16044,16541,16313],0); -ELEMENTS[64615] = Fluid3D([17108,17550,17402,17088],0); -ELEMENTS[64616] = Fluid3D([5515,5986,5951,5514],0); -ELEMENTS[64617] = Fluid3D([10569,10599,10178,11225],0); -ELEMENTS[64618] = Fluid3D([10599,10178,11225,10696],0); -ELEMENTS[64619] = Fluid3D([17472,17088,16818,17402],0); -ELEMENTS[64620] = Fluid3D([17472,17088,17402,17696],0); -ELEMENTS[64621] = Fluid3D([7050,7604,6536,7231],0); -ELEMENTS[64622] = Fluid3D([7050,7604,7231,7478],0); -ELEMENTS[64623] = Fluid3D([6536,7050,7231,6061],0); -ELEMENTS[64624] = Fluid3D([5800,5468,5614,4999],0); -ELEMENTS[64625] = Fluid3D([3805,3866,3511,4040],0); -ELEMENTS[64626] = Fluid3D([12440,13213,13372,12568],0); -ELEMENTS[64627] = Fluid3D([13372,12440,12568,12983],0); -ELEMENTS[64628] = Fluid3D([16116,16373,16324,16773],0); -ELEMENTS[64629] = Fluid3D([12365,12501,11704,12161],0); -ELEMENTS[64630] = Fluid3D([12365,12501,12161,13172],0); -ELEMENTS[64631] = Fluid3D([12365,12501,13172,13311],0); -ELEMENTS[64632] = Fluid3D([12365,12501,13311,12985],0); -ELEMENTS[64633] = Fluid3D([13172,12365,13311,12522],0); -ELEMENTS[64634] = Fluid3D([13172,12365,12522,12161],0); -ELEMENTS[64635] = Fluid3D([5401,5204,4662,5202],0); -ELEMENTS[64636] = Fluid3D([6316,6630,5908,5852],0); -ELEMENTS[64637] = Fluid3D([18307,18206,18011,18021],0); -ELEMENTS[64638] = Fluid3D([18307,18206,18021,18165],0); -ELEMENTS[64639] = Fluid3D([13219,13769,13999,13757],0); -ELEMENTS[64640] = Fluid3D([13219,13769,13757,12808],0); -ELEMENTS[64641] = Fluid3D([5123,5193,5665,4851],0); -ELEMENTS[64642] = Fluid3D([17351,17669,17757,17662],0); -ELEMENTS[64643] = Fluid3D([15212,15733,15300,15405],0); -ELEMENTS[64644] = Fluid3D([13373,14142,13667,14452],0); -ELEMENTS[64645] = Fluid3D([4353,4754,4181,4703],0); -ELEMENTS[64646] = Fluid3D([12849,12102,12551,11895],0); -ELEMENTS[64647] = Fluid3D([13759,13064,12756,13741],0); -ELEMENTS[64648] = Fluid3D([15244,15175,15936,15836],0); -ELEMENTS[64649] = Fluid3D([9052,8839,8157,8913],0); -ELEMENTS[64650] = Fluid3D([3675,3643,3913,4286],0); -ELEMENTS[64651] = Fluid3D([12602,12120,11976,11294],0); -ELEMENTS[64652] = Fluid3D([5995,6184,6278,6898],0); -ELEMENTS[64653] = Fluid3D([9141,9460,8587,8642],0); -ELEMENTS[64654] = Fluid3D([9055,8457,8273,7716],0); -ELEMENTS[64655] = Fluid3D([13458,12947,12691,13725],0); -ELEMENTS[64656] = Fluid3D([7157,7406,6430,6722],0); -ELEMENTS[64657] = Fluid3D([12687,13318,12023,12627],0); -ELEMENTS[64658] = Fluid3D([4623,4805,5186,5292],0); -ELEMENTS[64659] = Fluid3D([7061,7543,6821,7403],0); -ELEMENTS[64660] = Fluid3D([6821,7061,7403,6223],0); -ELEMENTS[64661] = Fluid3D([7061,7543,7403,8209],0); -ELEMENTS[64662] = Fluid3D([10035,10232,9527,9129],0); -ELEMENTS[64663] = Fluid3D([14175,13429,13321,13807],0); -ELEMENTS[64664] = Fluid3D([3432,3692,3686,3813],0); -ELEMENTS[64665] = Fluid3D([6174,6308,5828,5398],0); -ELEMENTS[64666] = Fluid3D([9543,8741,9903,9365],0); -ELEMENTS[64667] = Fluid3D([14329,13507,13859,14304],0); -ELEMENTS[64668] = Fluid3D([15673,15906,16275,15655],0); -ELEMENTS[64669] = Fluid3D([15673,15906,15655,15049],0); -ELEMENTS[64670] = Fluid3D([15655,15673,15049,15488],0); -ELEMENTS[64671] = Fluid3D([15906,16275,15655,16077],0); -ELEMENTS[64672] = Fluid3D([15906,16275,16077,16209],0); -ELEMENTS[64673] = Fluid3D([3641,3598,3880,3478],0); -ELEMENTS[64674] = Fluid3D([3641,3598,3478,3138],0); -ELEMENTS[64675] = Fluid3D([4165,4185,3932,3603],0); -ELEMENTS[64676] = Fluid3D([2326,2256,2638,2260],0); -ELEMENTS[64677] = Fluid3D([2326,2256,2260,2171],0); -ELEMENTS[64678] = Fluid3D([2326,2256,2171,2061],0); -ELEMENTS[64679] = Fluid3D([17090,17403,17298,16832],0); -ELEMENTS[64680] = Fluid3D([9513,9595,10520,9481],0); -ELEMENTS[64681] = Fluid3D([14439,14715,15182,14061],0); -ELEMENTS[64682] = Fluid3D([14439,14715,14061,13445],0); -ELEMENTS[64683] = Fluid3D([3932,4419,4060,4477],0); -ELEMENTS[64684] = Fluid3D([6679,6971,6706,6900],0); -ELEMENTS[64685] = Fluid3D([4451,4221,4314,4752],0); -ELEMENTS[64686] = Fluid3D([11580,12204,12503,11726],0); -ELEMENTS[64687] = Fluid3D([4255,4339,4288,3893],0); -ELEMENTS[64688] = Fluid3D([7442,6691,6643,6995],0); -ELEMENTS[64689] = Fluid3D([14498,14280,13921,14216],0); -ELEMENTS[64690] = Fluid3D([16208,15838,16190,15405],0); -ELEMENTS[64691] = Fluid3D([7126,7862,7299,7711],0); -ELEMENTS[64692] = Fluid3D([10235,9505,10670,10540],0); -ELEMENTS[64693] = Fluid3D([4305,3795,3877,3780],0); -ELEMENTS[64694] = Fluid3D([15348,15629,15291,14760],0); -ELEMENTS[64695] = Fluid3D([16795,17191,17084,17525],0); -ELEMENTS[64696] = Fluid3D([7126,6504,6802,7299],0); -ELEMENTS[64697] = Fluid3D([14553,15330,15206,14834],0); -ELEMENTS[64698] = Fluid3D([18001,18185,18072,18304],0); -ELEMENTS[64699] = Fluid3D([15519,15452,15428,16113],0); -ELEMENTS[64700] = Fluid3D([15981,15438,15616,15341],0); -ELEMENTS[64701] = Fluid3D([14117,14568,15167,14453],0); -ELEMENTS[64702] = Fluid3D([14117,14568,14453,14446],0); -ELEMENTS[64703] = Fluid3D([14568,15167,14453,15485],0); -ELEMENTS[64704] = Fluid3D([17758,17985,17954,17699],0); -ELEMENTS[64705] = Fluid3D([17758,17985,17699,18019],0); -ELEMENTS[64706] = Fluid3D([17758,17985,18019,17739],0); -ELEMENTS[64707] = Fluid3D([9648,9075,9472,8913],0); -ELEMENTS[64708] = Fluid3D([5086,4635,5452,4710],0); -ELEMENTS[64709] = Fluid3D([5086,4635,4710,4357],0); -ELEMENTS[64710] = Fluid3D([14697,14390,14032,14685],0); -ELEMENTS[64711] = Fluid3D([5331,5179,4746,4655],0); -ELEMENTS[64712] = Fluid3D([4489,4301,4853,4772],0); -ELEMENTS[64713] = Fluid3D([13928,14286,14315,14855],0); -ELEMENTS[64714] = Fluid3D([7880,7451,8427,8344],0); -ELEMENTS[64715] = Fluid3D([7574,8462,7542,8671],0); -ELEMENTS[64716] = Fluid3D([12869,12188,12627,13282],0); -ELEMENTS[64717] = Fluid3D([10263,10711,9475,11062],0); -ELEMENTS[64718] = Fluid3D([11607,11377,12389,11975],0); -ELEMENTS[64719] = Fluid3D([12389,11607,11975,12427],0); -ELEMENTS[64720] = Fluid3D([11607,11377,11975,10556],0); -ELEMENTS[64721] = Fluid3D([11607,11377,10556,11159],0); -ELEMENTS[64722] = Fluid3D([10556,11607,11159,10867],0); -ELEMENTS[64723] = Fluid3D([11607,11377,11159,11551],0); -ELEMENTS[64724] = Fluid3D([11607,11975,12427,11615],0); -ELEMENTS[64725] = Fluid3D([11607,11975,11615,10556],0); -ELEMENTS[64726] = Fluid3D([12427,11607,11615,10867],0); -ELEMENTS[64727] = Fluid3D([11607,11615,10867,10556],0); -ELEMENTS[64728] = Fluid3D([12024,11812,12710,12299],0); -ELEMENTS[64729] = Fluid3D([6206,6565,6282,5676],0); -ELEMENTS[64730] = Fluid3D([6206,6565,5676,5812],0); -ELEMENTS[64731] = Fluid3D([5676,6206,5812,5984],0); -ELEMENTS[64732] = Fluid3D([5676,6206,5984,5884],0); -ELEMENTS[64733] = Fluid3D([6282,6206,5676,5645],0); -ELEMENTS[64734] = Fluid3D([6206,5676,5645,5884],0); -ELEMENTS[64735] = Fluid3D([4237,4723,4650,4619],0); -ELEMENTS[64736] = Fluid3D([2421,2445,2173,2270],0); -ELEMENTS[64737] = Fluid3D([7974,7881,7537,7127],0); -ELEMENTS[64738] = Fluid3D([12922,13569,12737,13083],0); -ELEMENTS[64739] = Fluid3D([7385,8243,8232,7833],0); -ELEMENTS[64740] = Fluid3D([18247,18278,18186,17877],0); -ELEMENTS[64741] = Fluid3D([2964,2652,2805,3124],0); -ELEMENTS[64742] = Fluid3D([2805,2964,3124,3112],0); -ELEMENTS[64743] = Fluid3D([3489,3427,3490,3067],0); -ELEMENTS[64744] = Fluid3D([3489,3427,3067,2889],0); -ELEMENTS[64745] = Fluid3D([9030,8855,9927,9241],0); -ELEMENTS[64746] = Fluid3D([15916,15921,15003,15245],0); -ELEMENTS[64747] = Fluid3D([15916,15921,15245,15801],0); -ELEMENTS[64748] = Fluid3D([16139,16348,16542,15974],0); -ELEMENTS[64749] = Fluid3D([14315,14272,13891,13494],0); -ELEMENTS[64750] = Fluid3D([14315,14272,13494,13928],0); -ELEMENTS[64751] = Fluid3D([14315,14272,13928,14855],0); -ELEMENTS[64752] = Fluid3D([14272,13928,14855,14293],0); -ELEMENTS[64753] = Fluid3D([14272,13928,14293,13382],0); -ELEMENTS[64754] = Fluid3D([11074,11531,12498,11556],0); -ELEMENTS[64755] = Fluid3D([12100,12918,11923,11498],0); -ELEMENTS[64756] = Fluid3D([11923,12100,11498,11089],0); -ELEMENTS[64757] = Fluid3D([16332,16463,16578,16075],0); -ELEMENTS[64758] = Fluid3D([5816,5744,5421,5219],0); -ELEMENTS[64759] = Fluid3D([12833,13237,13674,13204],0); -ELEMENTS[64760] = Fluid3D([9187,8439,9090,9690],0); -ELEMENTS[64761] = Fluid3D([9607,9406,10426,10391],0); -ELEMENTS[64762] = Fluid3D([9998,10651,10185,9545],0); -ELEMENTS[64763] = Fluid3D([10185,9998,9545,8961],0); -ELEMENTS[64764] = Fluid3D([9998,10651,9545,9285],0); -ELEMENTS[64765] = Fluid3D([9545,9998,9285,8961],0); -ELEMENTS[64766] = Fluid3D([9311,9238,8402,8497],0); -ELEMENTS[64767] = Fluid3D([10065,10918,11080,10664],0); -ELEMENTS[64768] = Fluid3D([17940,18150,18325,18079],0); -ELEMENTS[64769] = Fluid3D([8687,8832,8151,9566],0); -ELEMENTS[64770] = Fluid3D([17533,17616,17720,17333],0); -ELEMENTS[64771] = Fluid3D([17533,17616,17333,17469],0); -ELEMENTS[64772] = Fluid3D([11079,11601,11923,11885],0); -ELEMENTS[64773] = Fluid3D([11549,10580,11395,10461],0); -ELEMENTS[64774] = Fluid3D([15424,15459,15950,14933],0); -ELEMENTS[64775] = Fluid3D([14904,15178,15394,14910],0); -ELEMENTS[64776] = Fluid3D([15178,15394,14910,14488],0); -ELEMENTS[64777] = Fluid3D([16042,15699,16393,15845],0); -ELEMENTS[64778] = Fluid3D([4833,5188,5205,4747],0); -ELEMENTS[64779] = Fluid3D([9993,9185,8747,8851],0); -ELEMENTS[64780] = Fluid3D([9185,8747,8851,8650],0); -ELEMENTS[64781] = Fluid3D([17682,17312,17730,17407],0); -ELEMENTS[64782] = Fluid3D([2263,2126,2028,1995],0); -ELEMENTS[64783] = Fluid3D([13375,14079,12894,13331],0); -ELEMENTS[64784] = Fluid3D([7848,7574,7591,8178],0); -ELEMENTS[64785] = Fluid3D([7574,7591,8178,7456],0); -ELEMENTS[64786] = Fluid3D([8178,7574,7456,8671],0); -ELEMENTS[64787] = Fluid3D([7591,8178,7456,7190],0); -ELEMENTS[64788] = Fluid3D([8178,7574,8671,7848],0); -ELEMENTS[64789] = Fluid3D([7591,8178,7190,8311],0); -ELEMENTS[64790] = Fluid3D([14612,13757,13849,13823],0); -ELEMENTS[64791] = Fluid3D([6498,6810,6605,7728],0); -ELEMENTS[64792] = Fluid3D([2548,2812,2456,2650],0); -ELEMENTS[64793] = Fluid3D([4585,4237,4094,3955],0); -ELEMENTS[64794] = Fluid3D([9469,10467,9919,10818],0); -ELEMENTS[64795] = Fluid3D([15599,15484,14820,15120],0); -ELEMENTS[64796] = Fluid3D([15351,15553,16098,15697],0); -ELEMENTS[64797] = Fluid3D([8387,9112,7935,8922],0); -ELEMENTS[64798] = Fluid3D([12490,11772,13049,12949],0); -ELEMENTS[64799] = Fluid3D([15579,15647,14934,15064],0); -ELEMENTS[64800] = Fluid3D([12534,12186,11610,12421],0); -ELEMENTS[64801] = Fluid3D([4663,4946,4293,4541],0); -ELEMENTS[64802] = Fluid3D([16396,16891,16751,16780],0); -ELEMENTS[64803] = Fluid3D([9741,8915,9095,9321],0); -ELEMENTS[64804] = Fluid3D([14542,13804,14449,14021],0); -ELEMENTS[64805] = Fluid3D([16136,16213,16623,16582],0); -ELEMENTS[64806] = Fluid3D([6087,5914,6587,6044],0); -ELEMENTS[64807] = Fluid3D([15509,16174,15336,15420],0); -ELEMENTS[64808] = Fluid3D([15296,15777,16026,15390],0); -ELEMENTS[64809] = Fluid3D([6312,5750,6645,6134],0); -ELEMENTS[64810] = Fluid3D([13421,14221,14170,13473],0); -ELEMENTS[64811] = Fluid3D([7952,7426,8367,7775],0); -ELEMENTS[64812] = Fluid3D([7209,7612,7128,8354],0); -ELEMENTS[64813] = Fluid3D([4103,4392,4821,4482],0); -ELEMENTS[64814] = Fluid3D([2687,2601,2535,2872],0); -ELEMENTS[64815] = Fluid3D([10436,10791,9723,9392],0); -ELEMENTS[64816] = Fluid3D([15433,15290,15393,14606],0); -ELEMENTS[64817] = Fluid3D([15269,15586,15638,15474],0); -ELEMENTS[64818] = Fluid3D([15269,15586,15474,14564],0); -ELEMENTS[64819] = Fluid3D([8050,8840,7883,8795],0); -ELEMENTS[64820] = Fluid3D([11088,11204,10098,11617],0); -ELEMENTS[64821] = Fluid3D([11088,11204,11617,12119],0); -ELEMENTS[64822] = Fluid3D([11850,12794,13149,11952],0); -ELEMENTS[64823] = Fluid3D([7594,7484,6801,6232],0); -ELEMENTS[64824] = Fluid3D([3964,4126,3530,3550],0); -ELEMENTS[64825] = Fluid3D([3530,3964,3550,4084],0); -ELEMENTS[64826] = Fluid3D([7268,6961,6311,6777],0); -ELEMENTS[64827] = Fluid3D([14697,14437,15360,14597],0); -ELEMENTS[64828] = Fluid3D([4540,4844,4206,4811],0); -ELEMENTS[64829] = Fluid3D([15483,15128,15384,15890],0); -ELEMENTS[64830] = Fluid3D([15483,15128,15890,15504],0); -ELEMENTS[64831] = Fluid3D([17171,17132,17347,16692],0); -ELEMENTS[64832] = Fluid3D([17192,17185,17109,16809],0); -ELEMENTS[64833] = Fluid3D([17185,17109,16809,16597],0); -ELEMENTS[64834] = Fluid3D([17192,17185,16809,16756],0); -ELEMENTS[64835] = Fluid3D([17185,16809,16756,16548],0); -ELEMENTS[64836] = Fluid3D([17109,16809,16597,16740],0); -ELEMENTS[64837] = Fluid3D([16809,17185,16597,16548],0); -ELEMENTS[64838] = Fluid3D([16597,16809,16548,16287],0); -ELEMENTS[64839] = Fluid3D([12198,11641,12871,12478],0); -ELEMENTS[64840] = Fluid3D([16440,16738,16612,17190],0); -ELEMENTS[64841] = Fluid3D([4226,4291,3741,3622],0); -ELEMENTS[64842] = Fluid3D([5727,6331,5957,6134],0); -ELEMENTS[64843] = Fluid3D([12806,12929,12058,11821],0); -ELEMENTS[64844] = Fluid3D([12538,13085,12226,11823],0); -ELEMENTS[64845] = Fluid3D([5532,5537,4827,4956],0); -ELEMENTS[64846] = Fluid3D([3581,3362,3776,3094],0); -ELEMENTS[64847] = Fluid3D([8651,9445,9375,9802],0); -ELEMENTS[64848] = Fluid3D([7932,8045,8853,8646],0); -ELEMENTS[64849] = Fluid3D([7932,8045,8646,8898],0); -ELEMENTS[64850] = Fluid3D([8045,8853,8646,8675],0); -ELEMENTS[64851] = Fluid3D([8646,8045,8675,7856],0); -ELEMENTS[64852] = Fluid3D([8646,8045,7856,8898],0); -ELEMENTS[64853] = Fluid3D([8225,7614,8615,8891],0); -ELEMENTS[64854] = Fluid3D([14063,14426,13718,13349],0); -ELEMENTS[64855] = Fluid3D([15604,16124,16382,16145],0); -ELEMENTS[64856] = Fluid3D([16124,16382,16145,16716],0); -ELEMENTS[64857] = Fluid3D([16145,16124,16716,16526],0); -ELEMENTS[64858] = Fluid3D([14000,14626,14025,14355],0); -ELEMENTS[64859] = Fluid3D([16600,16067,16194,16632],0); -ELEMENTS[64860] = Fluid3D([6306,6960,7087,7347],0); -ELEMENTS[64861] = Fluid3D([6960,7087,7347,7967],0); -ELEMENTS[64862] = Fluid3D([7087,7347,7967,7866],0); -ELEMENTS[64863] = Fluid3D([9599,9836,10535,10661],0); -ELEMENTS[64864] = Fluid3D([5808,5993,6677,6619],0); -ELEMENTS[64865] = Fluid3D([12155,12157,13079,12803],0); -ELEMENTS[64866] = Fluid3D([13525,13850,12831,12884],0); -ELEMENTS[64867] = Fluid3D([5354,5671,5967,5651],0); -ELEMENTS[64868] = Fluid3D([2778,2700,2681,3138],0); -ELEMENTS[64869] = Fluid3D([14852,14769,14874,15546],0); -ELEMENTS[64870] = Fluid3D([12075,11367,11721,12209],0); -ELEMENTS[64871] = Fluid3D([9252,9820,8515,9103],0); -ELEMENTS[64872] = Fluid3D([11178,11924,11673,11958],0); -ELEMENTS[64873] = Fluid3D([14096,13756,13858,12503],0); -ELEMENTS[64874] = Fluid3D([9582,10542,9691,10207],0); -ELEMENTS[64875] = Fluid3D([12014,12801,12089,11591],0); -ELEMENTS[64876] = Fluid3D([12014,12801,11591,12227],0); -ELEMENTS[64877] = Fluid3D([11591,12014,12227,11447],0); -ELEMENTS[64878] = Fluid3D([12089,12014,11591,11757],0); -ELEMENTS[64879] = Fluid3D([3067,3046,3490,3489],0); -ELEMENTS[64880] = Fluid3D([3067,3046,3489,2889],0); -ELEMENTS[64881] = Fluid3D([3067,3046,2889,2637],0); -ELEMENTS[64882] = Fluid3D([3046,2889,2637,3025],0); -ELEMENTS[64883] = Fluid3D([8925,8574,9216,9589],0); -ELEMENTS[64884] = Fluid3D([14569,15055,14322,14140],0); -ELEMENTS[64885] = Fluid3D([12275,13040,11776,12351],0); -ELEMENTS[64886] = Fluid3D([7927,7157,7635,6817],0); -ELEMENTS[64887] = Fluid3D([15392,15322,15383,15937],0); -ELEMENTS[64888] = Fluid3D([15322,15383,15937,15860],0); -ELEMENTS[64889] = Fluid3D([2438,2750,2436,2385],0); -ELEMENTS[64890] = Fluid3D([10872,9901,10325,10359],0); -ELEMENTS[64891] = Fluid3D([9213,8305,8678,9556],0); -ELEMENTS[64892] = Fluid3D([10077,9819,10618,10330],0); -ELEMENTS[64893] = Fluid3D([16802,17195,17073,16709],0); -ELEMENTS[64894] = Fluid3D([8540,9029,9476,9487],0); -ELEMENTS[64895] = Fluid3D([2606,2804,2538,2550],0); -ELEMENTS[64896] = Fluid3D([5172,5385,5133,5740],0); -ELEMENTS[64897] = Fluid3D([14965,14701,15234,14214],0); -ELEMENTS[64898] = Fluid3D([5863,5531,5110,5296],0); -ELEMENTS[64899] = Fluid3D([14271,13807,13336,13297],0); -ELEMENTS[64900] = Fluid3D([16195,15910,16281,15862],0); -ELEMENTS[64901] = Fluid3D([15910,16281,15862,15548],0); -ELEMENTS[64902] = Fluid3D([16195,15910,15862,15668],0); -ELEMENTS[64903] = Fluid3D([15910,15862,15668,15062],0); -ELEMENTS[64904] = Fluid3D([15862,15668,15062,15470],0); -ELEMENTS[64905] = Fluid3D([15862,16195,15668,16446],0); -ELEMENTS[64906] = Fluid3D([12050,11647,10983,11390],0); -ELEMENTS[64907] = Fluid3D([10983,12050,11390,12093],0); -ELEMENTS[64908] = Fluid3D([17795,18031,17895,17868],0); -ELEMENTS[64909] = Fluid3D([11382,11529,10475,11186],0); -ELEMENTS[64910] = Fluid3D([13988,13560,14377,13872],0); -ELEMENTS[64911] = Fluid3D([13405,13549,12788,14057],0); -ELEMENTS[64912] = Fluid3D([12302,11645,12159,12212],0); -ELEMENTS[64913] = Fluid3D([15410,15569,15881,15053],0); -ELEMENTS[64914] = Fluid3D([7633,7768,7123,8272],0); -ELEMENTS[64915] = Fluid3D([5165,5766,6000,5843],0); -ELEMENTS[64916] = Fluid3D([5766,6000,5843,6512],0); -ELEMENTS[64917] = Fluid3D([6000,5843,6512,7078],0); -ELEMENTS[64918] = Fluid3D([5843,5766,6512,6247],0); -ELEMENTS[64919] = Fluid3D([5843,6512,7078,6563],0); -ELEMENTS[64920] = Fluid3D([2160,2207,2263,2425],0); -ELEMENTS[64921] = Fluid3D([2263,2160,2425,2320],0); -ELEMENTS[64922] = Fluid3D([11059,10576,9914,11055],0); -ELEMENTS[64923] = Fluid3D([3746,3262,3450,3490],0); -ELEMENTS[64924] = Fluid3D([1752,1831,1888,2018],0); -ELEMENTS[64925] = Fluid3D([11062,10234,10711,9475],0); -ELEMENTS[64926] = Fluid3D([6961,6209,6311,6017],0); -ELEMENTS[64927] = Fluid3D([14707,14743,14953,15632],0); -ELEMENTS[64928] = Fluid3D([3327,3661,3916,3730],0); -ELEMENTS[64929] = Fluid3D([18166,18335,18082,18380],0); -ELEMENTS[64930] = Fluid3D([18308,18065,18221,18137],0); -ELEMENTS[64931] = Fluid3D([2338,2287,2588,2486],0); -ELEMENTS[64932] = Fluid3D([3693,3620,3322,3061],0); -ELEMENTS[64933] = Fluid3D([6419,6387,6944,6362],0); -ELEMENTS[64934] = Fluid3D([8193,8098,9102,7757],0); -ELEMENTS[64935] = Fluid3D([8193,8098,7757,7447],0); -ELEMENTS[64936] = Fluid3D([17610,17790,17399,17416],0); -ELEMENTS[64937] = Fluid3D([14259,14445,15022,14469],0); -ELEMENTS[64938] = Fluid3D([15043,14224,14905,14254],0); -ELEMENTS[64939] = Fluid3D([14224,14905,14254,14310],0); -ELEMENTS[64940] = Fluid3D([14254,14224,14310,13603],0); -ELEMENTS[64941] = Fluid3D([14224,14310,13603,14546],0); -ELEMENTS[64942] = Fluid3D([14254,14224,13603,13621],0); -ELEMENTS[64943] = Fluid3D([14224,13603,13621,13701],0); -ELEMENTS[64944] = Fluid3D([14254,14224,13621,14511],0); -ELEMENTS[64945] = Fluid3D([14224,13621,14511,13701],0); -ELEMENTS[64946] = Fluid3D([13603,14224,14546,13701],0); -ELEMENTS[64947] = Fluid3D([16809,17192,16756,16992],0); -ELEMENTS[64948] = Fluid3D([16809,17192,16992,17109],0); -ELEMENTS[64949] = Fluid3D([16756,16809,16992,16567],0); -ELEMENTS[64950] = Fluid3D([16756,16809,16567,16377],0); -ELEMENTS[64951] = Fluid3D([16756,16809,16377,16287],0); -ELEMENTS[64952] = Fluid3D([16809,16377,16287,16597],0); -ELEMENTS[64953] = Fluid3D([16809,16377,16597,16740],0); -ELEMENTS[64954] = Fluid3D([16756,16809,16287,16548],0); -ELEMENTS[64955] = Fluid3D([16809,16992,16567,16377],0); -ELEMENTS[64956] = Fluid3D([16809,16992,16377,16740],0); -ELEMENTS[64957] = Fluid3D([16809,16992,16740,17109],0); -ELEMENTS[64958] = Fluid3D([13530,12918,13870,13773],0); -ELEMENTS[64959] = Fluid3D([8925,8574,9589,8916],0); -ELEMENTS[64960] = Fluid3D([17486,17302,17075,17274],0); -ELEMENTS[64961] = Fluid3D([17075,17486,17274,17351],0); -ELEMENTS[64962] = Fluid3D([17075,17486,17351,17386],0); -ELEMENTS[64963] = Fluid3D([16731,17053,16998,16868],0); -ELEMENTS[64964] = Fluid3D([11475,11057,11095,10553],0); -ELEMENTS[64965] = Fluid3D([7361,6576,6769,6872],0); -ELEMENTS[64966] = Fluid3D([13228,13506,13997,14421],0); -ELEMENTS[64967] = Fluid3D([10940,10560,10398,11821],0); -ELEMENTS[64968] = Fluid3D([13122,12965,12180,12817],0); -ELEMENTS[64969] = Fluid3D([6278,6008,5995,6772],0); -ELEMENTS[64970] = Fluid3D([2628,2960,2834,3061],0); -ELEMENTS[64971] = Fluid3D([15898,16344,16398,16186],0); -ELEMENTS[64972] = Fluid3D([12200,12163,12283,11197],0); -ELEMENTS[64973] = Fluid3D([16235,16311,16146,15935],0); -ELEMENTS[64974] = Fluid3D([16311,16146,15935,16404],0); -ELEMENTS[64975] = Fluid3D([15935,16311,16404,16166],0); -ELEMENTS[64976] = Fluid3D([16404,15935,16166,15729],0); -ELEMENTS[64977] = Fluid3D([16146,15935,16404,16045],0); -ELEMENTS[64978] = Fluid3D([15935,16404,16045,15729],0); -ELEMENTS[64979] = Fluid3D([9065,9641,9401,10320],0); -ELEMENTS[64980] = Fluid3D([2751,2556,2777,2883],0); -ELEMENTS[64981] = Fluid3D([13218,12652,13334,14284],0); -ELEMENTS[64982] = Fluid3D([18365,18291,18134,18169],0); -ELEMENTS[64983] = Fluid3D([18023,18245,18071,17959],0); -ELEMENTS[64984] = Fluid3D([18023,18245,17959,18196],0); -ELEMENTS[64985] = Fluid3D([2187,2235,2144,2383],0); -ELEMENTS[64986] = Fluid3D([15537,15910,15668,15062],0); -ELEMENTS[64987] = Fluid3D([13566,14283,14027,13754],0); -ELEMENTS[64988] = Fluid3D([5453,5835,5788,6297],0); -ELEMENTS[64989] = Fluid3D([5453,5835,6297,5661],0); -ELEMENTS[64990] = Fluid3D([12612,12394,13691,13052],0); -ELEMENTS[64991] = Fluid3D([2383,2346,2448,2235],0); -ELEMENTS[64992] = Fluid3D([14543,14891,14621,14807],0); -ELEMENTS[64993] = Fluid3D([14621,14543,14807,14043],0); -ELEMENTS[64994] = Fluid3D([14543,14807,14043,14327],0); -ELEMENTS[64995] = Fluid3D([14543,14807,14327,15339],0); -ELEMENTS[64996] = Fluid3D([11560,11992,12390,11986],0); -ELEMENTS[64997] = Fluid3D([5963,5979,5494,5738],0); -ELEMENTS[64998] = Fluid3D([12734,12859,13302,12080],0); -ELEMENTS[64999] = Fluid3D([6892,6918,6081,6589],0); -ELEMENTS[65000] = Fluid3D([15925,15411,15515,15549],0); -ELEMENTS[65001] = Fluid3D([15411,15515,15549,14637],0); -ELEMENTS[65002] = Fluid3D([13375,12738,13858,13898],0); -ELEMENTS[65003] = Fluid3D([6677,6197,5830,6388],0); -ELEMENTS[65004] = Fluid3D([16138,15852,16324,16633],0); -ELEMENTS[65005] = Fluid3D([17597,17785,17503,17893],0); -ELEMENTS[65006] = Fluid3D([11643,12184,12140,10817],0); -ELEMENTS[65007] = Fluid3D([4443,3966,4449,3990],0); -ELEMENTS[65008] = Fluid3D([4839,4715,4159,4390],0); -ELEMENTS[65009] = Fluid3D([4434,4399,3993,4472],0); -ELEMENTS[65010] = Fluid3D([13769,12934,13630,12808],0); -ELEMENTS[65011] = Fluid3D([9935,9488,10474,10552],0); -ELEMENTS[65012] = Fluid3D([10158,10461,11395,10580],0); -ELEMENTS[65013] = Fluid3D([10158,10461,10580,9585],0); -ELEMENTS[65014] = Fluid3D([11395,10158,10580,10800],0); -ELEMENTS[65015] = Fluid3D([10158,10580,10800,9363],0); -ELEMENTS[65016] = Fluid3D([10158,10580,9363,9585],0); -ELEMENTS[65017] = Fluid3D([10580,9363,9585,9993],0); -ELEMENTS[65018] = Fluid3D([9363,9585,9993,8747],0); -ELEMENTS[65019] = Fluid3D([9363,9585,8747,9608],0); -ELEMENTS[65020] = Fluid3D([9585,10580,9993,10368],0); -ELEMENTS[65021] = Fluid3D([16278,15668,16195,16446],0); -ELEMENTS[65022] = Fluid3D([5780,5607,5486,6126],0); -ELEMENTS[65023] = Fluid3D([5780,5607,6126,5811],0); -ELEMENTS[65024] = Fluid3D([10004,10010,10666,11474],0); -ELEMENTS[65025] = Fluid3D([13660,13874,14343,13871],0); -ELEMENTS[65026] = Fluid3D([15216,15630,15473,15652],0); -ELEMENTS[65027] = Fluid3D([15216,15630,15652,15124],0); -ELEMENTS[65028] = Fluid3D([5103,5299,5364,5657],0); -ELEMENTS[65029] = Fluid3D([5103,5299,5657,5637],0); -ELEMENTS[65030] = Fluid3D([9057,8708,9894,9223],0); -ELEMENTS[65031] = Fluid3D([8708,9894,9223,9402],0); -ELEMENTS[65032] = Fluid3D([12208,11389,12604,11910],0); -ELEMENTS[65033] = Fluid3D([5864,5953,6568,5828],0); -ELEMENTS[65034] = Fluid3D([5586,5489,6234,5617],0); -ELEMENTS[65035] = Fluid3D([5586,5489,5617,4968],0); -ELEMENTS[65036] = Fluid3D([6234,5586,5617,5969],0); -ELEMENTS[65037] = Fluid3D([4693,4798,4793,4272],0); -ELEMENTS[65038] = Fluid3D([4722,4344,5109,4693],0); -ELEMENTS[65039] = Fluid3D([6862,7200,6868,7698],0); -ELEMENTS[65040] = Fluid3D([7200,6868,7698,6736],0); -ELEMENTS[65041] = Fluid3D([7200,6868,6736,6600],0); -ELEMENTS[65042] = Fluid3D([6553,6532,6372,5733],0); -ELEMENTS[65043] = Fluid3D([3072,3441,2998,3361],0); -ELEMENTS[65044] = Fluid3D([3072,3441,3361,3269],0); -ELEMENTS[65045] = Fluid3D([2998,3072,3361,2756],0); -ELEMENTS[65046] = Fluid3D([9017,9458,9416,10455],0); -ELEMENTS[65047] = Fluid3D([11273,10568,10945,9795],0); -ELEMENTS[65048] = Fluid3D([8524,9455,8834,8771],0); -ELEMENTS[65049] = Fluid3D([8524,9455,8771,8302],0); -ELEMENTS[65050] = Fluid3D([13639,14394,13897,13328],0); -ELEMENTS[65051] = Fluid3D([8502,9043,8743,7749],0); -ELEMENTS[65052] = Fluid3D([15570,15505,15697,15161],0); -ELEMENTS[65053] = Fluid3D([9144,9693,8473,9485],0); -ELEMENTS[65054] = Fluid3D([8473,9144,9485,8913],0); -ELEMENTS[65055] = Fluid3D([9563,8898,9383,9883],0); -ELEMENTS[65056] = Fluid3D([8898,9383,9883,9202],0); -ELEMENTS[65057] = Fluid3D([8898,9383,9202,8507],0); -ELEMENTS[65058] = Fluid3D([14145,13913,14519,13950],0); -ELEMENTS[65059] = Fluid3D([17659,17901,17812,17840],0); -ELEMENTS[65060] = Fluid3D([5250,5738,5053,5963],0); -ELEMENTS[65061] = Fluid3D([5250,5738,5963,5494],0); -ELEMENTS[65062] = Fluid3D([2046,2170,2062,1907],0); -ELEMENTS[65063] = Fluid3D([18485,18573,18532,18453],0); -ELEMENTS[65064] = Fluid3D([14467,13782,13836,14870],0); -ELEMENTS[65065] = Fluid3D([15927,15658,15587,15321],0); -ELEMENTS[65066] = Fluid3D([3205,3433,3570,3219],0); -ELEMENTS[65067] = Fluid3D([8079,7337,7639,6993],0); -ELEMENTS[65068] = Fluid3D([3115,3011,3065,3502],0); -ELEMENTS[65069] = Fluid3D([3065,3115,3502,3458],0); -ELEMENTS[65070] = Fluid3D([7737,8686,7790,7401],0); -ELEMENTS[65071] = Fluid3D([18494,18438,18465,18288],0); -ELEMENTS[65072] = Fluid3D([3879,3638,4088,3985],0); -ELEMENTS[65073] = Fluid3D([9357,9335,10241,9493],0); -ELEMENTS[65074] = Fluid3D([13666,14259,14469,13718],0); -ELEMENTS[65075] = Fluid3D([14469,13666,13718,13691],0); -ELEMENTS[65076] = Fluid3D([8524,7939,7514,7750],0); -ELEMENTS[65077] = Fluid3D([8524,7939,7750,7082],0); -ELEMENTS[65078] = Fluid3D([3139,3504,3595,3339],0); -ELEMENTS[65079] = Fluid3D([6942,6421,7588,7198],0); -ELEMENTS[65080] = Fluid3D([7588,6942,7198,6928],0); -ELEMENTS[65081] = Fluid3D([17311,17222,16786,16967],0); -ELEMENTS[65082] = Fluid3D([11613,12167,13049,12816],0); -ELEMENTS[65083] = Fluid3D([7836,8737,8692,8585],0); -ELEMENTS[65084] = Fluid3D([15795,15200,15573,15920],0); -ELEMENTS[65085] = Fluid3D([2892,2583,2635,2607],0); -ELEMENTS[65086] = Fluid3D([15689,16024,16078,16149],0); -ELEMENTS[65087] = Fluid3D([3593,3853,3818,3919],0); -ELEMENTS[65088] = Fluid3D([12543,13272,13337,12538],0); -ELEMENTS[65089] = Fluid3D([13337,12543,12538,12174],0); -ELEMENTS[65090] = Fluid3D([12543,13272,12538,12801],0); -ELEMENTS[65091] = Fluid3D([12543,12538,12174,11108],0); -ELEMENTS[65092] = Fluid3D([12543,13272,12801,12089],0); -ELEMENTS[65093] = Fluid3D([8864,8671,8791,9484],0); -ELEMENTS[65094] = Fluid3D([11565,10714,11183,11290],0); -ELEMENTS[65095] = Fluid3D([11565,10714,11290,11108],0); -ELEMENTS[65096] = Fluid3D([11183,11565,11290,12174],0); -ELEMENTS[65097] = Fluid3D([11565,11290,12174,11108],0); -ELEMENTS[65098] = Fluid3D([11290,12174,11108,11016],0); -ELEMENTS[65099] = Fluid3D([11290,12174,11016,12055],0); -ELEMENTS[65100] = Fluid3D([11108,11290,11016,10714],0); -ELEMENTS[65101] = Fluid3D([11290,12174,12055,11183],0); -ELEMENTS[65102] = Fluid3D([12055,11290,11183,11016],0); -ELEMENTS[65103] = Fluid3D([11290,11183,11016,10714],0); -ELEMENTS[65104] = Fluid3D([3528,3285,3157,3560],0); -ELEMENTS[65105] = Fluid3D([17702,17935,17872,17699],0); -ELEMENTS[65106] = Fluid3D([17702,17935,17699,17954],0); -ELEMENTS[65107] = Fluid3D([12918,12944,11932,11997],0); -ELEMENTS[65108] = Fluid3D([7784,8090,6901,6899],0); -ELEMENTS[65109] = Fluid3D([5188,5523,5804,6131],0); -ELEMENTS[65110] = Fluid3D([5523,5804,6131,5830],0); -ELEMENTS[65111] = Fluid3D([5523,5804,5830,5278],0); -ELEMENTS[65112] = Fluid3D([4608,4992,4558,4288],0); -ELEMENTS[65113] = Fluid3D([15177,15398,14416,14798],0); -ELEMENTS[65114] = Fluid3D([12504,11848,12615,12237],0); -ELEMENTS[65115] = Fluid3D([10096,9984,10233,9231],0); -ELEMENTS[65116] = Fluid3D([16019,16150,16380,16100],0); -ELEMENTS[65117] = Fluid3D([16150,16380,16100,16752],0); -ELEMENTS[65118] = Fluid3D([15500,15640,15548,15772],0); -ELEMENTS[65119] = Fluid3D([1849,1959,1756,1807],0); -ELEMENTS[65120] = Fluid3D([11851,11541,11392,10561],0); -ELEMENTS[65121] = Fluid3D([7741,8115,8311,7190],0); -ELEMENTS[65122] = Fluid3D([10594,10419,10994,9893],0); -ELEMENTS[65123] = Fluid3D([11282,11118,10407,10432],0); -ELEMENTS[65124] = Fluid3D([10396,10307,10058,9103],0); -ELEMENTS[65125] = Fluid3D([3814,4052,4258,4044],0); -ELEMENTS[65126] = Fluid3D([4258,3814,4044,3894],0); -ELEMENTS[65127] = Fluid3D([17592,17329,17269,17701],0); -ELEMENTS[65128] = Fluid3D([17056,16751,16723,16891],0); -ELEMENTS[65129] = Fluid3D([17056,16751,16891,16780],0); -ELEMENTS[65130] = Fluid3D([8184,8587,7756,8642],0); -ELEMENTS[65131] = Fluid3D([5807,6313,5854,5894],0); -ELEMENTS[65132] = Fluid3D([2817,2626,2724,3064],0); -ELEMENTS[65133] = Fluid3D([9279,8582,9437,10074],0); -ELEMENTS[65134] = Fluid3D([14286,13485,13720,13511],0); -ELEMENTS[65135] = Fluid3D([9761,10720,9902,10666],0); -ELEMENTS[65136] = Fluid3D([5827,6466,5707,6042],0); -ELEMENTS[65137] = Fluid3D([6945,6920,6208,7118],0); -ELEMENTS[65138] = Fluid3D([6945,6920,7118,7458],0); -ELEMENTS[65139] = Fluid3D([6920,7118,7458,6428],0); -ELEMENTS[65140] = Fluid3D([7458,6920,6428,7135],0); -ELEMENTS[65141] = Fluid3D([7458,6920,7135,7717],0); -ELEMENTS[65142] = Fluid3D([6920,6428,7135,6988],0); -ELEMENTS[65143] = Fluid3D([6920,6428,6988,6520],0); -ELEMENTS[65144] = Fluid3D([6920,6428,6520,6208],0); -ELEMENTS[65145] = Fluid3D([6920,6428,6208,7118],0); -ELEMENTS[65146] = Fluid3D([6428,7135,6988,6898],0); -ELEMENTS[65147] = Fluid3D([7135,6988,6898,7717],0); -ELEMENTS[65148] = Fluid3D([6988,6898,7717,7733],0); -ELEMENTS[65149] = Fluid3D([6988,6920,6520,7025],0); -ELEMENTS[65150] = Fluid3D([6520,6988,7025,6184],0); -ELEMENTS[65151] = Fluid3D([7135,6920,6988,7717],0); -ELEMENTS[65152] = Fluid3D([16781,17100,16834,17189],0); -ELEMENTS[65153] = Fluid3D([16834,16781,17189,16886],0); -ELEMENTS[65154] = Fluid3D([16834,16781,16886,16434],0); -ELEMENTS[65155] = Fluid3D([16781,17100,17189,17069],0); -ELEMENTS[65156] = Fluid3D([17189,16834,16886,17248],0); -ELEMENTS[65157] = Fluid3D([17189,16781,17069,16931],0); -ELEMENTS[65158] = Fluid3D([17069,17189,16931,17377],0); -ELEMENTS[65159] = Fluid3D([17069,17189,17377,17566],0); -ELEMENTS[65160] = Fluid3D([16781,17189,16886,16931],0); -ELEMENTS[65161] = Fluid3D([16931,17069,17377,17518],0); -ELEMENTS[65162] = Fluid3D([17069,17377,17518,17566],0); -ELEMENTS[65163] = Fluid3D([7197,6393,6636,6306],0); -ELEMENTS[65164] = Fluid3D([14994,14657,14531,15261],0); -ELEMENTS[65165] = Fluid3D([2471,2601,2778,2872],0); -ELEMENTS[65166] = Fluid3D([2926,2779,3112,3062],0); -ELEMENTS[65167] = Fluid3D([12059,11120,11880,11914],0); -ELEMENTS[65168] = Fluid3D([2009,1924,1911,1795],0); -ELEMENTS[65169] = Fluid3D([17439,17505,17629,17041],0); -ELEMENTS[65170] = Fluid3D([7443,7326,6921,7272],0); -ELEMENTS[65171] = Fluid3D([3950,4209,4363,4669],0); -ELEMENTS[65172] = Fluid3D([7000,6714,7061,7734],0); -ELEMENTS[65173] = Fluid3D([7061,7000,7734,7403],0); -ELEMENTS[65174] = Fluid3D([7734,7061,7403,8209],0); -ELEMENTS[65175] = Fluid3D([7061,7000,7403,6223],0); -ELEMENTS[65176] = Fluid3D([4927,4906,5520,5625],0); -ELEMENTS[65177] = Fluid3D([1802,1919,1836,1739],0); -ELEMENTS[65178] = Fluid3D([7342,7169,7978,6841],0); -ELEMENTS[65179] = Fluid3D([17856,17575,17697,17889],0); -ELEMENTS[65180] = Fluid3D([12027,12149,12409,12917],0); -ELEMENTS[65181] = Fluid3D([12027,12149,12917,12981],0); -ELEMENTS[65182] = Fluid3D([12917,12027,12981,12745],0); -ELEMENTS[65183] = Fluid3D([12409,12027,12917,12736],0); -ELEMENTS[65184] = Fluid3D([12917,12409,12736,13892],0); -ELEMENTS[65185] = Fluid3D([17271,17387,17035,16973],0); -ELEMENTS[65186] = Fluid3D([17387,17035,16973,16848],0); -ELEMENTS[65187] = Fluid3D([17271,17387,16973,16805],0); -ELEMENTS[65188] = Fluid3D([17035,16973,16848,16542],0); -ELEMENTS[65189] = Fluid3D([17035,16973,16542,16485],0); -ELEMENTS[65190] = Fluid3D([17035,16973,16485,16767],0); -ELEMENTS[65191] = Fluid3D([17035,17271,16973,16767],0); -ELEMENTS[65192] = Fluid3D([18514,18423,18400,18381],0); -ELEMENTS[65193] = Fluid3D([6515,5821,6364,7031],0); -ELEMENTS[65194] = Fluid3D([8695,7781,8691,8797],0); -ELEMENTS[65195] = Fluid3D([8691,8695,8797,9692],0); -ELEMENTS[65196] = Fluid3D([8695,8797,9692,8538],0); -ELEMENTS[65197] = Fluid3D([8695,8797,8538,7781],0); -ELEMENTS[65198] = Fluid3D([8538,8695,7781,8244],0); -ELEMENTS[65199] = Fluid3D([8538,8695,8244,9161],0); -ELEMENTS[65200] = Fluid3D([9692,8695,8538,9161],0); -ELEMENTS[65201] = Fluid3D([8797,8538,7781,8576],0); -ELEMENTS[65202] = Fluid3D([8797,8538,8576,9692],0); -ELEMENTS[65203] = Fluid3D([8695,8244,9161,9645],0); -ELEMENTS[65204] = Fluid3D([8216,9130,8547,8165],0); -ELEMENTS[65205] = Fluid3D([8547,8216,8165,7608],0); -ELEMENTS[65206] = Fluid3D([13788,13847,14094,12884],0); -ELEMENTS[65207] = Fluid3D([16186,15790,16358,16398],0); -ELEMENTS[65208] = Fluid3D([10533,9599,10535,9489],0); -ELEMENTS[65209] = Fluid3D([13306,12372,13403,12606],0); -ELEMENTS[65210] = Fluid3D([10005,11034,10538,11444],0); -ELEMENTS[65211] = Fluid3D([5307,5772,5605,5654],0); -ELEMENTS[65212] = Fluid3D([12160,12547,12973,12191],0); -ELEMENTS[65213] = Fluid3D([7241,7487,7505,8067],0); -ELEMENTS[65214] = Fluid3D([15631,15548,16184,16281],0); -ELEMENTS[65215] = Fluid3D([13190,13705,14361,13287],0); -ELEMENTS[65216] = Fluid3D([14400,13810,14957,14383],0); -ELEMENTS[65217] = Fluid3D([14957,14400,14383,14645],0); -ELEMENTS[65218] = Fluid3D([7873,7926,7353,7829],0); -ELEMENTS[65219] = Fluid3D([7353,7873,7829,7112],0); -ELEMENTS[65220] = Fluid3D([8919,9560,9962,9510],0); -ELEMENTS[65221] = Fluid3D([15224,15402,14949,14444],0); -ELEMENTS[65222] = Fluid3D([10983,10270,11390,10330],0); -ELEMENTS[65223] = Fluid3D([11390,10983,10330,11647],0); -ELEMENTS[65224] = Fluid3D([10983,10270,10330,9393],0); -ELEMENTS[65225] = Fluid3D([8424,9156,8382,8104],0); -ELEMENTS[65226] = Fluid3D([8382,8424,8104,7605],0); -ELEMENTS[65227] = Fluid3D([8424,8104,7605,8009],0); -ELEMENTS[65228] = Fluid3D([8424,9156,8104,8009],0); -ELEMENTS[65229] = Fluid3D([13174,13630,13610,12934],0); -ELEMENTS[65230] = Fluid3D([13610,13174,12934,12414],0); -ELEMENTS[65231] = Fluid3D([13174,12934,12414,12808],0); -ELEMENTS[65232] = Fluid3D([12934,13610,12414,13005],0); -ELEMENTS[65233] = Fluid3D([15900,16108,16067,16194],0); -ELEMENTS[65234] = Fluid3D([16541,16727,16868,16159],0); -ELEMENTS[65235] = Fluid3D([15268,15312,15081,14478],0); -ELEMENTS[65236] = Fluid3D([15906,15739,15592,15305],0); -ELEMENTS[65237] = Fluid3D([4122,4297,4822,4357],0); -ELEMENTS[65238] = Fluid3D([10308,10337,9327,10613],0); -ELEMENTS[65239] = Fluid3D([16076,15602,15861,15573],0); -ELEMENTS[65240] = Fluid3D([15861,16076,15573,16224],0); -ELEMENTS[65241] = Fluid3D([15573,15861,16224,15597],0); -ELEMENTS[65242] = Fluid3D([13633,13680,13308,12500],0); -ELEMENTS[65243] = Fluid3D([10277,9685,10249,9265],0); -ELEMENTS[65244] = Fluid3D([15469,15708,15038,14935],0); -ELEMENTS[65245] = Fluid3D([11339,11716,10775,10867],0); -ELEMENTS[65246] = Fluid3D([11716,10775,10867,10310],0); -ELEMENTS[65247] = Fluid3D([10775,10867,10310,10027],0); -ELEMENTS[65248] = Fluid3D([11339,11716,10867,11707],0); -ELEMENTS[65249] = Fluid3D([15944,15840,15308,15338],0); -ELEMENTS[65250] = Fluid3D([15944,15840,15338,15936],0); -ELEMENTS[65251] = Fluid3D([15338,15944,15936,15175],0); -ELEMENTS[65252] = Fluid3D([15338,15944,15175,15380],0); -ELEMENTS[65253] = Fluid3D([15338,15944,15380,15308],0); -ELEMENTS[65254] = Fluid3D([15175,15338,15380,14798],0); -ELEMENTS[65255] = Fluid3D([11931,12287,11900,12702],0); -ELEMENTS[65256] = Fluid3D([11257,10865,10540,10509],0); -ELEMENTS[65257] = Fluid3D([11257,10865,10509,11441],0); -ELEMENTS[65258] = Fluid3D([11257,10865,11441,12123],0); -ELEMENTS[65259] = Fluid3D([10865,10509,11441,11395],0); -ELEMENTS[65260] = Fluid3D([12500,12935,12391,13680],0); -ELEMENTS[65261] = Fluid3D([18196,18137,17959,17947],0); -ELEMENTS[65262] = Fluid3D([18137,17959,17947,17770],0); -ELEMENTS[65263] = Fluid3D([4106,4204,4742,4414],0); -ELEMENTS[65264] = Fluid3D([10019,9693,9144,9485],0); -ELEMENTS[65265] = Fluid3D([9144,10019,9485,9648],0); -ELEMENTS[65266] = Fluid3D([9144,10019,9648,10187],0); -ELEMENTS[65267] = Fluid3D([10019,9648,10187,11120],0); -ELEMENTS[65268] = Fluid3D([10019,9485,9648,10345],0); -ELEMENTS[65269] = Fluid3D([9648,10019,10345,11120],0); -ELEMENTS[65270] = Fluid3D([6460,6669,7420,6957],0); -ELEMENTS[65271] = Fluid3D([6669,7420,6957,7291],0); -ELEMENTS[65272] = Fluid3D([6460,6669,6957,6066],0); -ELEMENTS[65273] = Fluid3D([13542,12940,12849,14049],0); -ELEMENTS[65274] = Fluid3D([17678,17505,17444,17589],0); -ELEMENTS[65275] = Fluid3D([8304,9046,8120,8466],0); -ELEMENTS[65276] = Fluid3D([8622,9228,9328,9696],0); -ELEMENTS[65277] = Fluid3D([8622,9228,9696,8355],0); -ELEMENTS[65278] = Fluid3D([17745,17744,17668,17563],0); -ELEMENTS[65279] = Fluid3D([17745,17744,17563,17370],0); -ELEMENTS[65280] = Fluid3D([7093,7662,7107,6797],0); -ELEMENTS[65281] = Fluid3D([7093,7662,6797,7538],0); -ELEMENTS[65282] = Fluid3D([15579,15789,15943,16363],0); -ELEMENTS[65283] = Fluid3D([18504,18354,18447,18523],0); -ELEMENTS[65284] = Fluid3D([4814,4929,4430,4949],0); -ELEMENTS[65285] = Fluid3D([4937,4845,5382,4657],0); -ELEMENTS[65286] = Fluid3D([13288,13957,14086,13972],0); -ELEMENTS[65287] = Fluid3D([14485,14952,14877,15502],0); -ELEMENTS[65288] = Fluid3D([18484,18328,18223,18506],0); -ELEMENTS[65289] = Fluid3D([18484,18328,18506,18434],0); -ELEMENTS[65290] = Fluid3D([1985,2012,1969,2197],0); -ELEMENTS[65291] = Fluid3D([15521,15361,14751,14941],0); -ELEMENTS[65292] = Fluid3D([13637,13643,14379,14604],0); -ELEMENTS[65293] = Fluid3D([5873,6209,5760,5670],0); -ELEMENTS[65294] = Fluid3D([5760,5873,5670,5320],0); -ELEMENTS[65295] = Fluid3D([5793,6304,6209,6769],0); -ELEMENTS[65296] = Fluid3D([5793,6304,6769,6054],0); -ELEMENTS[65297] = Fluid3D([6899,6320,6997,7401],0); -ELEMENTS[65298] = Fluid3D([10224,10062,9521,8987],0); -ELEMENTS[65299] = Fluid3D([9653,9998,8961,9285],0); -ELEMENTS[65300] = Fluid3D([17946,18078,17972,17638],0); -ELEMENTS[65301] = Fluid3D([16265,16553,16477,15765],0); -ELEMENTS[65302] = Fluid3D([5979,5494,6132,6002],0); -ELEMENTS[65303] = Fluid3D([17734,17760,17605,18073],0); -ELEMENTS[65304] = Fluid3D([13812,14525,14506,14533],0); -ELEMENTS[65305] = Fluid3D([13812,14525,14533,15090],0); -ELEMENTS[65306] = Fluid3D([5595,5090,5225,4889],0); -ELEMENTS[65307] = Fluid3D([4634,4203,4756,4969],0); -ELEMENTS[65308] = Fluid3D([4756,4634,4969,5395],0); -ELEMENTS[65309] = Fluid3D([14095,13449,14128,14155],0); -ELEMENTS[65310] = Fluid3D([16520,17066,17019,16614],0); -ELEMENTS[65311] = Fluid3D([11436,11811,12309,11466],0); -ELEMENTS[65312] = Fluid3D([11207,10782,11098,11955],0); -ELEMENTS[65313] = Fluid3D([16002,16052,15492,15975],0); -ELEMENTS[65314] = Fluid3D([16002,16052,15975,16425],0); -ELEMENTS[65315] = Fluid3D([16052,15975,16425,15492],0); -ELEMENTS[65316] = Fluid3D([10451,10241,10145,9357],0); -ELEMENTS[65317] = Fluid3D([3802,3586,3989,4116],0); -ELEMENTS[65318] = Fluid3D([4593,4912,4854,4352],0); -ELEMENTS[65319] = Fluid3D([14733,14693,15131,14548],0); -ELEMENTS[65320] = Fluid3D([16124,16382,16716,16477],0); -ELEMENTS[65321] = Fluid3D([9653,9230,9393,8657],0); -ELEMENTS[65322] = Fluid3D([18217,18123,18064,17905],0); -ELEMENTS[65323] = Fluid3D([13125,12441,13166,12150],0); -ELEMENTS[65324] = Fluid3D([9613,10298,10254,11103],0); -ELEMENTS[65325] = Fluid3D([6723,6415,7461,7171],0); -ELEMENTS[65326] = Fluid3D([18342,18275,18461,18201],0); -ELEMENTS[65327] = Fluid3D([14559,14891,15366,15436],0); -ELEMENTS[65328] = Fluid3D([17300,17117,17158,16601],0); -ELEMENTS[65329] = Fluid3D([7692,8388,8132,8820],0); -ELEMENTS[65330] = Fluid3D([12810,12317,12299,11812],0); -ELEMENTS[65331] = Fluid3D([9430,9373,8424,9111],0); -ELEMENTS[65332] = Fluid3D([10205,11238,10322,10848],0); -ELEMENTS[65333] = Fluid3D([11238,10322,10848,11284],0); -ELEMENTS[65334] = Fluid3D([12051,12174,11016,11709],0); -ELEMENTS[65335] = Fluid3D([16656,16951,16486,16471],0); -ELEMENTS[65336] = Fluid3D([16656,16951,16471,16941],0); -ELEMENTS[65337] = Fluid3D([14196,14387,14895,14369],0); -ELEMENTS[65338] = Fluid3D([14895,14196,14369,14609],0); -ELEMENTS[65339] = Fluid3D([12111,13174,12414,12297],0); -ELEMENTS[65340] = Fluid3D([12414,12111,12297,11884],0); -ELEMENTS[65341] = Fluid3D([12111,13174,12297,12058],0); -ELEMENTS[65342] = Fluid3D([12297,12111,12058,11184],0); -ELEMENTS[65343] = Fluid3D([12111,12058,11184,11821],0); -ELEMENTS[65344] = Fluid3D([12297,12414,11884,12808],0); -ELEMENTS[65345] = Fluid3D([11884,12297,12808,13017],0); -ELEMENTS[65346] = Fluid3D([2243,2291,2066,2245],0); -ELEMENTS[65347] = Fluid3D([3780,3306,3561,4015],0); -ELEMENTS[65348] = Fluid3D([4292,4629,4276,3930],0); -ELEMENTS[65349] = Fluid3D([5996,5915,5857,5316],0); -ELEMENTS[65350] = Fluid3D([12113,12902,11581,12638],0); -ELEMENTS[65351] = Fluid3D([3967,4102,4077,3595],0); -ELEMENTS[65352] = Fluid3D([2130,2401,2248,2233],0); -ELEMENTS[65353] = Fluid3D([8484,8956,9080,9829],0); -ELEMENTS[65354] = Fluid3D([6637,6375,6119,6084],0); -ELEMENTS[65355] = Fluid3D([6119,6637,6084,7085],0); -ELEMENTS[65356] = Fluid3D([12733,13046,12647,13141],0); -ELEMENTS[65357] = Fluid3D([11129,11267,10587,10390],0); -ELEMENTS[65358] = Fluid3D([13766,12826,12595,13404],0); -ELEMENTS[65359] = Fluid3D([12595,13766,13404,12767],0); -ELEMENTS[65360] = Fluid3D([7939,8524,7551,7581],0); -ELEMENTS[65361] = Fluid3D([3881,4208,3838,4225],0); -ELEMENTS[65362] = Fluid3D([3820,3922,3430,3878],0); -ELEMENTS[65363] = Fluid3D([5669,5073,4965,5543],0); -ELEMENTS[65364] = Fluid3D([7069,7914,8116,7831],0); -ELEMENTS[65365] = Fluid3D([5456,5361,5852,5644],0); -ELEMENTS[65366] = Fluid3D([11456,10290,11324,10243],0); -ELEMENTS[65367] = Fluid3D([11955,12217,11559,11098],0); -ELEMENTS[65368] = Fluid3D([11559,11955,11098,10782],0); -ELEMENTS[65369] = Fluid3D([11098,11559,10782,10370],0); -ELEMENTS[65370] = Fluid3D([12217,11559,11098,11460],0); -ELEMENTS[65371] = Fluid3D([12418,11605,12366,11292],0); -ELEMENTS[65372] = Fluid3D([17414,17234,17571,17107],0); -ELEMENTS[65373] = Fluid3D([17872,17826,17935,17485],0); -ELEMENTS[65374] = Fluid3D([16849,16473,16800,17039],0); -ELEMENTS[65375] = Fluid3D([3274,2961,3155,2853],0); -ELEMENTS[65376] = Fluid3D([12165,12281,12968,11495],0); -ELEMENTS[65377] = Fluid3D([18188,18145,18095,18403],0); -ELEMENTS[65378] = Fluid3D([14002,13441,13819,14464],0); -ELEMENTS[65379] = Fluid3D([14061,14089,14033,14579],0); -ELEMENTS[65380] = Fluid3D([14033,14061,14579,14715],0); -ELEMENTS[65381] = Fluid3D([14089,14033,14579,13915],0); -ELEMENTS[65382] = Fluid3D([14061,14089,14579,14937],0); -ELEMENTS[65383] = Fluid3D([2007,2185,2098,1956],0); -ELEMENTS[65384] = Fluid3D([2845,2615,2487,2630],0); -ELEMENTS[65385] = Fluid3D([14693,13998,14342,14741],0); -ELEMENTS[65386] = Fluid3D([9438,10350,10794,10034],0); -ELEMENTS[65387] = Fluid3D([10350,10794,10034,10577],0); -ELEMENTS[65388] = Fluid3D([10034,10350,10577,9438],0); -ELEMENTS[65389] = Fluid3D([10794,10034,10577,11273],0); -ELEMENTS[65390] = Fluid3D([10794,9438,10034,9795],0); -ELEMENTS[65391] = Fluid3D([10034,10794,9795,11273],0); -ELEMENTS[65392] = Fluid3D([9438,10034,9795,9002],0); -ELEMENTS[65393] = Fluid3D([10350,10794,10577,10980],0); -ELEMENTS[65394] = Fluid3D([10577,10350,10980,9598],0); -ELEMENTS[65395] = Fluid3D([10577,10350,9598,9438],0); -ELEMENTS[65396] = Fluid3D([7544,6682,7275,6350],0); -ELEMENTS[65397] = Fluid3D([11578,11070,10977,12220],0); -ELEMENTS[65398] = Fluid3D([16582,16496,17083,16805],0); -ELEMENTS[65399] = Fluid3D([18604,18523,18504,18447],0); -ELEMENTS[65400] = Fluid3D([8580,9442,9063,9348],0); -ELEMENTS[65401] = Fluid3D([9499,9265,8455,8820],0); -ELEMENTS[65402] = Fluid3D([5173,5710,5521,5385],0); -ELEMENTS[65403] = Fluid3D([9201,8520,9105,8288],0); -ELEMENTS[65404] = Fluid3D([17890,18165,18048,18056],0); -ELEMENTS[65405] = Fluid3D([2380,2233,2598,2401],0); -ELEMENTS[65406] = Fluid3D([5655,6281,6109,6042],0); -ELEMENTS[65407] = Fluid3D([11923,12750,11885,11601],0); -ELEMENTS[65408] = Fluid3D([6072,5775,6564,6413],0); -ELEMENTS[65409] = Fluid3D([10716,10830,10543,9812],0); -ELEMENTS[65410] = Fluid3D([17239,17473,17540,16839],0); -ELEMENTS[65411] = Fluid3D([13611,13445,13596,12678],0); -ELEMENTS[65412] = Fluid3D([13611,13445,12678,13175],0); -ELEMENTS[65413] = Fluid3D([12101,12514,11698,12179],0); -ELEMENTS[65414] = Fluid3D([12101,12514,12179,13089],0); -ELEMENTS[65415] = Fluid3D([12179,12101,13089,12847],0); -ELEMENTS[65416] = Fluid3D([12179,12101,12847,12175],0); -ELEMENTS[65417] = Fluid3D([12179,12101,12175,10967],0); -ELEMENTS[65418] = Fluid3D([12179,12101,10967,11045],0); -ELEMENTS[65419] = Fluid3D([16322,16108,16515,16363],0); -ELEMENTS[65420] = Fluid3D([8427,8819,9113,9319],0); -ELEMENTS[65421] = Fluid3D([13943,13754,14351,13177],0); -ELEMENTS[65422] = Fluid3D([15857,15575,14992,15607],0); -ELEMENTS[65423] = Fluid3D([6164,5498,5460,5917],0); -ELEMENTS[65424] = Fluid3D([5498,5460,5917,5043],0); -ELEMENTS[65425] = Fluid3D([5097,4794,5099,5535],0); -ELEMENTS[65426] = Fluid3D([9413,8810,8635,9785],0); -ELEMENTS[65427] = Fluid3D([15349,14870,15769,15104],0); -ELEMENTS[65428] = Fluid3D([7326,7344,7024,7832],0); -ELEMENTS[65429] = Fluid3D([9470,9970,8860,9617],0); -ELEMENTS[65430] = Fluid3D([13776,13547,13390,14126],0); -ELEMENTS[65431] = Fluid3D([13390,13776,14126,13295],0); -ELEMENTS[65432] = Fluid3D([13547,13390,14126,14257],0); -ELEMENTS[65433] = Fluid3D([13776,13547,14126,14358],0); -ELEMENTS[65434] = Fluid3D([14126,13776,14358,14816],0); -ELEMENTS[65435] = Fluid3D([9679,8723,9188,9507],0); -ELEMENTS[65436] = Fluid3D([9115,9576,8816,10098],0); -ELEMENTS[65437] = Fluid3D([4745,4893,5035,4429],0); -ELEMENTS[65438] = Fluid3D([12435,12406,12456,13056],0); -ELEMENTS[65439] = Fluid3D([2995,3122,3334,2986],0); -ELEMENTS[65440] = Fluid3D([3334,2995,2986,3037],0); -ELEMENTS[65441] = Fluid3D([2986,3334,3037,3415],0); -ELEMENTS[65442] = Fluid3D([3037,2986,3415,2854],0); -ELEMENTS[65443] = Fluid3D([2995,3122,2986,2705],0); -ELEMENTS[65444] = Fluid3D([2995,2986,3037,2705],0); -ELEMENTS[65445] = Fluid3D([2986,3037,2705,2854],0); -ELEMENTS[65446] = Fluid3D([16725,17075,17194,17302],0); -ELEMENTS[65447] = Fluid3D([5045,5573,5518,5144],0); -ELEMENTS[65448] = Fluid3D([5573,5518,5144,6004],0); -ELEMENTS[65449] = Fluid3D([5045,5573,5144,5790],0); -ELEMENTS[65450] = Fluid3D([5977,6022,5948,6815],0); -ELEMENTS[65451] = Fluid3D([5977,6022,6815,7146],0); -ELEMENTS[65452] = Fluid3D([15702,15800,15116,15320],0); -ELEMENTS[65453] = Fluid3D([10308,10383,10227,10871],0); -ELEMENTS[65454] = Fluid3D([13462,13644,13844,12784],0); -ELEMENTS[65455] = Fluid3D([17267,17011,16865,17333],0); -ELEMENTS[65456] = Fluid3D([6676,6360,5747,6233],0); -ELEMENTS[65457] = Fluid3D([5958,6111,5576,5205],0); -ELEMENTS[65458] = Fluid3D([16086,15712,15306,15974],0); -ELEMENTS[65459] = Fluid3D([3156,3173,3187,2859],0); -ELEMENTS[65460] = Fluid3D([15012,14395,14785,14627],0); -ELEMENTS[65461] = Fluid3D([5871,5413,5839,5416],0); -ELEMENTS[65462] = Fluid3D([8198,9003,8532,8533],0); -ELEMENTS[65463] = Fluid3D([9459,8629,9379,9544],0); -ELEMENTS[65464] = Fluid3D([18135,17872,17935,18147],0); -ELEMENTS[65465] = Fluid3D([13989,13545,13103,13366],0); -ELEMENTS[65466] = Fluid3D([1721,1746,1616,1702],0); -ELEMENTS[65467] = Fluid3D([1746,1616,1702,1613],0); -ELEMENTS[65468] = Fluid3D([1616,1702,1613,1721],0); -ELEMENTS[65469] = Fluid3D([1721,1746,1702,1818],0); -ELEMENTS[65470] = Fluid3D([1746,1702,1818,1759],0); -ELEMENTS[65471] = Fluid3D([1702,1818,1759,1613],0); -ELEMENTS[65472] = Fluid3D([1702,1818,1613,1711],0); -ELEMENTS[65473] = Fluid3D([1702,1818,1711,1721],0); -ELEMENTS[65474] = Fluid3D([1613,1702,1711,1721],0); -ELEMENTS[65475] = Fluid3D([1759,1702,1613,1746],0); -ELEMENTS[65476] = Fluid3D([13020,13392,13749,12519],0); -ELEMENTS[65477] = Fluid3D([10195,10581,10013,10869],0); -ELEMENTS[65478] = Fluid3D([15091,14561,15617,15136],0); -ELEMENTS[65479] = Fluid3D([15091,14561,15136,14741],0); -ELEMENTS[65480] = Fluid3D([15091,14561,14741,14182],0); -ELEMENTS[65481] = Fluid3D([15136,15091,14741,15378],0); -ELEMENTS[65482] = Fluid3D([15091,14741,15378,14891],0); -ELEMENTS[65483] = Fluid3D([9510,9408,9982,10630],0); -ELEMENTS[65484] = Fluid3D([17816,17510,17766,17666],0); -ELEMENTS[65485] = Fluid3D([12501,12583,12000,12448],0); -ELEMENTS[65486] = Fluid3D([14825,15260,14912,15471],0); -ELEMENTS[65487] = Fluid3D([14951,15077,15476,14816],0); -ELEMENTS[65488] = Fluid3D([5323,5318,5124,5864],0); -ELEMENTS[65489] = Fluid3D([10222,11102,11201,10659],0); -ELEMENTS[65490] = Fluid3D([7809,7938,8336,8814],0); -ELEMENTS[65491] = Fluid3D([14002,13819,14731,14464],0); -ELEMENTS[65492] = Fluid3D([8961,8518,9653,9285],0); -ELEMENTS[65493] = Fluid3D([8206,8426,8946,9129],0); -ELEMENTS[65494] = Fluid3D([8946,8206,9129,8910],0); -ELEMENTS[65495] = Fluid3D([18197,18203,18032,17921],0); -ELEMENTS[65496] = Fluid3D([18032,18197,17921,17931],0); -ELEMENTS[65497] = Fluid3D([18032,18197,17931,18141],0); -ELEMENTS[65498] = Fluid3D([17921,18032,17931,17629],0); -ELEMENTS[65499] = Fluid3D([17931,17921,17629,17934],0); -ELEMENTS[65500] = Fluid3D([17629,17931,17934,17815],0); -ELEMENTS[65501] = Fluid3D([17931,17934,17815,18141],0); -ELEMENTS[65502] = Fluid3D([17629,17931,17815,17927],0); -ELEMENTS[65503] = Fluid3D([17931,17921,17934,18197],0); -ELEMENTS[65504] = Fluid3D([17815,17931,18141,17927],0); -ELEMENTS[65505] = Fluid3D([17934,17629,17815,17505],0); -ELEMENTS[65506] = Fluid3D([17934,17931,18197,18141],0); -ELEMENTS[65507] = Fluid3D([18032,17931,17629,17927],0); -ELEMENTS[65508] = Fluid3D([16201,16269,16391,15985],0); -ELEMENTS[65509] = Fluid3D([16391,16201,15985,16749],0); -ELEMENTS[65510] = Fluid3D([12001,12020,12878,12881],0); -ELEMENTS[65511] = Fluid3D([12878,12001,12881,13125],0); -ELEMENTS[65512] = Fluid3D([12881,12878,13125,13954],0); -ELEMENTS[65513] = Fluid3D([12881,12878,13954,13489],0); -ELEMENTS[65514] = Fluid3D([12881,12878,13489,12020],0); -ELEMENTS[65515] = Fluid3D([9571,10392,10674,10255],0); -ELEMENTS[65516] = Fluid3D([7222,6431,6688,6245],0); -ELEMENTS[65517] = Fluid3D([3109,3044,2784,3072],0); -ELEMENTS[65518] = Fluid3D([17664,17913,18012,17979],0); -ELEMENTS[65519] = Fluid3D([9986,9295,9812,9192],0); -ELEMENTS[65520] = Fluid3D([9986,9295,9192,9549],0); -ELEMENTS[65521] = Fluid3D([9295,9812,9192,8623],0); -ELEMENTS[65522] = Fluid3D([9192,9295,8623,9549],0); -ELEMENTS[65523] = Fluid3D([9192,9986,9549,10543],0); -ELEMENTS[65524] = Fluid3D([10003,9673,10065,9308],0); -ELEMENTS[65525] = Fluid3D([9673,10065,9308,9640],0); -ELEMENTS[65526] = Fluid3D([10065,9308,9640,10873],0); -ELEMENTS[65527] = Fluid3D([2675,2944,2723,2595],0); -ELEMENTS[65528] = Fluid3D([10296,10967,10388,9955],0); -ELEMENTS[65529] = Fluid3D([17644,17870,17630,17928],0); -ELEMENTS[65530] = Fluid3D([7867,7119,6978,6805],0); -ELEMENTS[65531] = Fluid3D([7119,6978,6805,6181],0); -ELEMENTS[65532] = Fluid3D([2240,2116,2340,2410],0); -ELEMENTS[65533] = Fluid3D([8934,8638,7966,8046],0); -ELEMENTS[65534] = Fluid3D([15059,14380,14333,14571],0); -ELEMENTS[65535] = Fluid3D([14333,15059,14571,15406],0); -ELEMENTS[65536] = Fluid3D([14380,14333,14571,14229],0); -ELEMENTS[65537] = Fluid3D([14333,14571,14229,13329],0); -ELEMENTS[65538] = Fluid3D([14380,14333,14229,13329],0); -ELEMENTS[65539] = Fluid3D([14571,14380,14229,15059],0); -ELEMENTS[65540] = Fluid3D([18269,18102,17958,18103],0); -ELEMENTS[65541] = Fluid3D([10028,10228,9934,9104],0); -ELEMENTS[65542] = Fluid3D([10028,10228,9104,9029],0); -ELEMENTS[65543] = Fluid3D([16419,16415,16362,15801],0); -ELEMENTS[65544] = Fluid3D([12622,11560,12390,12933],0); -ELEMENTS[65545] = Fluid3D([8469,8170,7815,8811],0); -ELEMENTS[65546] = Fluid3D([4800,4363,5115,4688],0); -ELEMENTS[65547] = Fluid3D([14617,14049,14191,14180],0); -ELEMENTS[65548] = Fluid3D([10850,10056,11212,11277],0); -ELEMENTS[65549] = Fluid3D([15085,15308,15626,15976],0); -ELEMENTS[65550] = Fluid3D([13261,14003,13964,13140],0); -ELEMENTS[65551] = Fluid3D([4979,5175,4896,4537],0); -ELEMENTS[65552] = Fluid3D([2194,2163,2416,2292],0); -ELEMENTS[65553] = Fluid3D([5045,5144,4462,4507],0); -ELEMENTS[65554] = Fluid3D([4462,5045,4507,4404],0); -ELEMENTS[65555] = Fluid3D([4507,4462,4404,3946],0); -ELEMENTS[65556] = Fluid3D([5045,4507,4404,4375],0); -ELEMENTS[65557] = Fluid3D([4507,4404,4375,3869],0); -ELEMENTS[65558] = Fluid3D([8837,8447,8305,8735],0); -ELEMENTS[65559] = Fluid3D([8305,8837,8735,9556],0); -ELEMENTS[65560] = Fluid3D([8837,8735,9556,9427],0); -ELEMENTS[65561] = Fluid3D([10826,11688,11183,11044],0); -ELEMENTS[65562] = Fluid3D([12410,13279,12949,12490],0); -ELEMENTS[65563] = Fluid3D([18155,18357,18305,18097],0); -ELEMENTS[65564] = Fluid3D([11201,12121,11639,12025],0); -ELEMENTS[65565] = Fluid3D([13141,13336,12459,13297],0); -ELEMENTS[65566] = Fluid3D([16777,17062,16453,16378],0); -ELEMENTS[65567] = Fluid3D([16453,16777,16378,16381],0); -ELEMENTS[65568] = Fluid3D([16777,16378,16381,16965],0); -ELEMENTS[65569] = Fluid3D([16777,16378,16965,17062],0); -ELEMENTS[65570] = Fluid3D([16453,16777,16381,16939],0); -ELEMENTS[65571] = Fluid3D([16777,16381,16939,17111],0); -ELEMENTS[65572] = Fluid3D([16381,16777,16965,17130],0); -ELEMENTS[65573] = Fluid3D([14279,13771,13383,13851],0); -ELEMENTS[65574] = Fluid3D([12932,12310,12635,11966],0); -ELEMENTS[65575] = Fluid3D([14769,14312,14066,13750],0); -ELEMENTS[65576] = Fluid3D([11973,12703,12366,11407],0); -ELEMENTS[65577] = Fluid3D([11973,12703,11407,10882],0); -ELEMENTS[65578] = Fluid3D([11407,11973,10882,10810],0); -ELEMENTS[65579] = Fluid3D([12366,11973,11407,11605],0); -ELEMENTS[65580] = Fluid3D([11973,11407,11605,10810],0); -ELEMENTS[65581] = Fluid3D([9217,9945,10142,9848],0); -ELEMENTS[65582] = Fluid3D([10142,9217,9848,9962],0); -ELEMENTS[65583] = Fluid3D([9217,9945,9848,8895],0); -ELEMENTS[65584] = Fluid3D([9848,10142,9962,11164],0); -ELEMENTS[65585] = Fluid3D([9217,9848,9962,8745],0); -ELEMENTS[65586] = Fluid3D([8926,8122,8477,8885],0); -ELEMENTS[65587] = Fluid3D([17770,17959,18071,18227],0); -ELEMENTS[65588] = Fluid3D([1919,2019,1836,1870],0); -ELEMENTS[65589] = Fluid3D([18475,18526,18412,18421],0); -ELEMENTS[65590] = Fluid3D([18475,18526,18421,18413],0); -ELEMENTS[65591] = Fluid3D([18475,18526,18413,18550],0); -ELEMENTS[65592] = Fluid3D([18413,18475,18550,18521],0); -ELEMENTS[65593] = Fluid3D([3433,3547,3570,4118],0); -ELEMENTS[65594] = Fluid3D([15218,15404,15660,15303],0); -ELEMENTS[65595] = Fluid3D([9063,9676,10115,9442],0); -ELEMENTS[65596] = Fluid3D([9063,9676,9442,8693],0); -ELEMENTS[65597] = Fluid3D([9770,10269,9701,11256],0); -ELEMENTS[65598] = Fluid3D([16245,16121,15728,15548],0); -ELEMENTS[65599] = Fluid3D([2477,2635,2756,2998],0); -ELEMENTS[65600] = Fluid3D([5014,4820,4405,5328],0); -ELEMENTS[65601] = Fluid3D([5014,4820,5328,5448],0); -ELEMENTS[65602] = Fluid3D([14329,14587,14304,15280],0); -ELEMENTS[65603] = Fluid3D([9062,9582,8469,8786],0); -ELEMENTS[65604] = Fluid3D([8469,9062,8786,7545],0); -ELEMENTS[65605] = Fluid3D([9062,9582,8786,9528],0); -ELEMENTS[65606] = Fluid3D([8786,9062,9528,9286],0); -ELEMENTS[65607] = Fluid3D([9062,9582,9528,10207],0); -ELEMENTS[65608] = Fluid3D([9582,9528,10207,9289],0); -ELEMENTS[65609] = Fluid3D([9528,10207,9289,9286],0); -ELEMENTS[65610] = Fluid3D([9528,10207,9286,9062],0); -ELEMENTS[65611] = Fluid3D([9289,9528,9286,8786],0); -ELEMENTS[65612] = Fluid3D([9289,9528,8786,9582],0); -ELEMENTS[65613] = Fluid3D([16100,16383,16752,16285],0); -ELEMENTS[65614] = Fluid3D([11821,11878,11619,10791],0); -ELEMENTS[65615] = Fluid3D([15790,15770,16358,15502],0); -ELEMENTS[65616] = Fluid3D([11327,11254,10410,10856],0); -ELEMENTS[65617] = Fluid3D([10410,11327,10856,11463],0); -ELEMENTS[65618] = Fluid3D([10410,11327,11463,11359],0); -ELEMENTS[65619] = Fluid3D([12116,11020,11551,11590],0); -ELEMENTS[65620] = Fluid3D([13879,14491,14147,14019],0); -ELEMENTS[65621] = Fluid3D([17515,17136,17014,17283],0); -ELEMENTS[65622] = Fluid3D([9289,9131,8487,8124],0); -ELEMENTS[65623] = Fluid3D([17633,17316,17579,17729],0); -ELEMENTS[65624] = Fluid3D([2980,2706,2620,2547],0); -ELEMENTS[65625] = Fluid3D([13441,13458,13819,12679],0); -ELEMENTS[65626] = Fluid3D([12413,13081,13037,12032],0); -ELEMENTS[65627] = Fluid3D([2831,2803,3143,3128],0); -ELEMENTS[65628] = Fluid3D([5473,5397,6183,5924],0); -ELEMENTS[65629] = Fluid3D([8897,9622,8468,9386],0); -ELEMENTS[65630] = Fluid3D([16748,16562,17058,16699],0); -ELEMENTS[65631] = Fluid3D([18021,18307,18165,18290],0); -ELEMENTS[65632] = Fluid3D([6448,6580,5854,5864],0); -ELEMENTS[65633] = Fluid3D([17615,17677,17700,17254],0); -ELEMENTS[65634] = Fluid3D([18044,18200,18280,18277],0); -ELEMENTS[65635] = Fluid3D([17138,17463,17478,17120],0); -ELEMENTS[65636] = Fluid3D([9928,10228,10087,9029],0); -ELEMENTS[65637] = Fluid3D([8882,9191,10185,8961],0); -ELEMENTS[65638] = Fluid3D([13050,12899,13555,12579],0); -ELEMENTS[65639] = Fluid3D([13555,13050,12579,12476],0); -ELEMENTS[65640] = Fluid3D([13050,12899,12579,12476],0); -ELEMENTS[65641] = Fluid3D([6669,6953,6464,7472],0); -ELEMENTS[65642] = Fluid3D([8668,9373,8968,8424],0); -ELEMENTS[65643] = Fluid3D([8668,9373,8424,9083],0); -ELEMENTS[65644] = Fluid3D([14916,14905,14310,13997],0); -ELEMENTS[65645] = Fluid3D([13527,13510,13374,12378],0); -ELEMENTS[65646] = Fluid3D([13730,13421,12546,13473],0); -ELEMENTS[65647] = Fluid3D([16429,16109,15992,15677],0); -ELEMENTS[65648] = Fluid3D([4767,5095,5052,4569],0); -ELEMENTS[65649] = Fluid3D([5035,4429,4679,4745],0); -ELEMENTS[65650] = Fluid3D([5700,5999,6348,5658],0); -ELEMENTS[65651] = Fluid3D([11360,11269,11589,10603],0); -ELEMENTS[65652] = Fluid3D([16683,16889,16155,16576],0); -ELEMENTS[65653] = Fluid3D([13072,12237,12995,12683],0); -ELEMENTS[65654] = Fluid3D([6772,6885,7259,7981],0); -ELEMENTS[65655] = Fluid3D([15014,15567,15515,14856],0); -ELEMENTS[65656] = Fluid3D([9144,10137,9764,8805],0); -ELEMENTS[65657] = Fluid3D([14596,14639,14746,13999],0); -ELEMENTS[65658] = Fluid3D([14639,14746,13999,14466],0); -ELEMENTS[65659] = Fluid3D([16570,16914,16830,17049],0); -ELEMENTS[65660] = Fluid3D([9459,8811,9260,9973],0); -ELEMENTS[65661] = Fluid3D([12556,11732,12279,12186],0); -ELEMENTS[65662] = Fluid3D([5702,5057,5799,5334],0); -ELEMENTS[65663] = Fluid3D([6730,6937,7273,7133],0); -ELEMENTS[65664] = Fluid3D([8962,9181,9863,10309],0); -ELEMENTS[65665] = Fluid3D([11536,10908,11211,11888],0); -ELEMENTS[65666] = Fluid3D([4791,5155,5352,5602],0); -ELEMENTS[65667] = Fluid3D([5155,5352,5602,5486],0); -ELEMENTS[65668] = Fluid3D([5352,4791,5602,5187],0); -ELEMENTS[65669] = Fluid3D([12194,11369,12729,12401],0); -ELEMENTS[65670] = Fluid3D([9851,8876,8934,9892],0); -ELEMENTS[65671] = Fluid3D([7096,7776,6936,7970],0); -ELEMENTS[65672] = Fluid3D([7096,7776,7970,7510],0); -ELEMENTS[65673] = Fluid3D([18010,18187,18255,18073],0); -ELEMENTS[65674] = Fluid3D([14882,15391,15667,15780],0); -ELEMENTS[65675] = Fluid3D([5164,4669,4693,5109],0); -ELEMENTS[65676] = Fluid3D([16011,15735,16219,16620],0); -ELEMENTS[65677] = Fluid3D([3358,3344,3696,3476],0); -ELEMENTS[65678] = Fluid3D([13758,13969,13798,13085],0); -ELEMENTS[65679] = Fluid3D([10883,10283,11045,9894],0); -ELEMENTS[65680] = Fluid3D([11656,11922,11548,10634],0); -ELEMENTS[65681] = Fluid3D([11922,11548,10634,11852],0); -ELEMENTS[65682] = Fluid3D([3180,3147,3355,2940],0); -ELEMENTS[65683] = Fluid3D([17004,17082,17444,17173],0); -ELEMENTS[65684] = Fluid3D([11366,12181,11434,11014],0); -ELEMENTS[65685] = Fluid3D([11434,11366,11014,10425],0); -ELEMENTS[65686] = Fluid3D([14847,14155,14247,14095],0); -ELEMENTS[65687] = Fluid3D([15116,14874,14397,15320],0); -ELEMENTS[65688] = Fluid3D([14137,14933,14525,14854],0); -ELEMENTS[65689] = Fluid3D([14137,14933,14854,13822],0); -ELEMENTS[65690] = Fluid3D([4268,4450,4480,4013],0); -ELEMENTS[65691] = Fluid3D([4268,4450,4013,3692],0); -ELEMENTS[65692] = Fluid3D([4480,4268,4013,3739],0); -ELEMENTS[65693] = Fluid3D([4268,4013,3739,3692],0); -ELEMENTS[65694] = Fluid3D([4013,3739,3692,3991],0); -ELEMENTS[65695] = Fluid3D([4013,3739,3991,4480],0); -ELEMENTS[65696] = Fluid3D([3692,4013,3991,4223],0); -ELEMENTS[65697] = Fluid3D([4013,3991,4223,4480],0); -ELEMENTS[65698] = Fluid3D([3739,3692,3991,3686],0); -ELEMENTS[65699] = Fluid3D([3991,3739,3686,3595],0); -ELEMENTS[65700] = Fluid3D([3692,4013,4223,4450],0); -ELEMENTS[65701] = Fluid3D([4013,4223,4450,4480],0); -ELEMENTS[65702] = Fluid3D([3991,3692,4223,3813],0); -ELEMENTS[65703] = Fluid3D([15326,14881,15319,15728],0); -ELEMENTS[65704] = Fluid3D([15326,14881,15728,15062],0); -ELEMENTS[65705] = Fluid3D([16437,16579,17051,16514],0); -ELEMENTS[65706] = Fluid3D([16437,16579,16514,15815],0); -ELEMENTS[65707] = Fluid3D([13022,13902,13532,13459],0); -ELEMENTS[65708] = Fluid3D([2027,2130,2188,2365],0); -ELEMENTS[65709] = Fluid3D([16893,16949,17354,17264],0); -ELEMENTS[65710] = Fluid3D([4864,4486,4485,5047],0); -ELEMENTS[65711] = Fluid3D([4864,4486,5047,5143],0); -ELEMENTS[65712] = Fluid3D([4864,4486,5143,5077],0); -ELEMENTS[65713] = Fluid3D([9982,10630,9985,9510],0); -ELEMENTS[65714] = Fluid3D([9985,9982,9510,9107],0); -ELEMENTS[65715] = Fluid3D([9510,9985,9107,9206],0); -ELEMENTS[65716] = Fluid3D([9510,9985,9206,9560],0); -ELEMENTS[65717] = Fluid3D([10630,9985,9510,10928],0); -ELEMENTS[65718] = Fluid3D([15964,15706,15801,15684],0); -ELEMENTS[65719] = Fluid3D([13558,13784,12995,12615],0); -ELEMENTS[65720] = Fluid3D([13784,12995,12615,13014],0); -ELEMENTS[65721] = Fluid3D([12995,12615,13014,11861],0); -ELEMENTS[65722] = Fluid3D([12995,12615,11861,12237],0); -ELEMENTS[65723] = Fluid3D([12995,13558,12615,12979],0); -ELEMENTS[65724] = Fluid3D([6646,7504,6651,7168],0); -ELEMENTS[65725] = Fluid3D([3934,3622,4244,4226],0); -ELEMENTS[65726] = Fluid3D([12256,12557,12582,12127],0); -ELEMENTS[65727] = Fluid3D([10548,9653,10270,9285],0); -ELEMENTS[65728] = Fluid3D([11782,12585,12910,12389],0); -ELEMENTS[65729] = Fluid3D([13925,13937,14264,14768],0); -ELEMENTS[65730] = Fluid3D([14956,14493,15160,14389],0); -ELEMENTS[65731] = Fluid3D([3874,3528,3560,3982],0); -ELEMENTS[65732] = Fluid3D([18471,18560,18556,18466],0); -ELEMENTS[65733] = Fluid3D([17161,17213,17008,17270],0); -ELEMENTS[65734] = Fluid3D([14773,14724,14095,14710],0); -ELEMENTS[65735] = Fluid3D([8804,8917,7968,8599],0); -ELEMENTS[65736] = Fluid3D([7968,8804,8599,8185],0); -ELEMENTS[65737] = Fluid3D([7968,8804,8185,8398],0); -ELEMENTS[65738] = Fluid3D([8804,8185,8398,8754],0); -ELEMENTS[65739] = Fluid3D([8599,7968,8185,7402],0); -ELEMENTS[65740] = Fluid3D([8804,8599,8185,8754],0); -ELEMENTS[65741] = Fluid3D([8599,8185,8754,7402],0); -ELEMENTS[65742] = Fluid3D([8185,8398,8754,8246],0); -ELEMENTS[65743] = Fluid3D([8754,8185,8246,7402],0); -ELEMENTS[65744] = Fluid3D([8185,8398,8246,7465],0); -ELEMENTS[65745] = Fluid3D([8185,8398,7465,7968],0); -ELEMENTS[65746] = Fluid3D([7465,8185,7968,7402],0); -ELEMENTS[65747] = Fluid3D([7465,8185,7402,8246],0); -ELEMENTS[65748] = Fluid3D([9990,10546,9440,9702],0); -ELEMENTS[65749] = Fluid3D([6364,6951,6904,6341],0); -ELEMENTS[65750] = Fluid3D([4843,5013,4952,4359],0); -ELEMENTS[65751] = Fluid3D([17935,18115,18135,18147],0); -ELEMENTS[65752] = Fluid3D([13669,12865,13304,12405],0); -ELEMENTS[65753] = Fluid3D([5261,4978,5684,5330],0); -ELEMENTS[65754] = Fluid3D([5261,4978,5330,5093],0); -ELEMENTS[65755] = Fluid3D([4978,5684,5330,5249],0); -ELEMENTS[65756] = Fluid3D([7319,7667,7972,8492],0); -ELEMENTS[65757] = Fluid3D([14026,14506,14533,13812],0); -ELEMENTS[65758] = Fluid3D([7897,8495,9034,8616],0); -ELEMENTS[65759] = Fluid3D([16097,15611,15807,15939],0); -ELEMENTS[65760] = Fluid3D([15009,14419,15113,14702],0); -ELEMENTS[65761] = Fluid3D([10603,11858,11589,11360],0); -ELEMENTS[65762] = Fluid3D([16258,16784,16715,16593],0); -ELEMENTS[65763] = Fluid3D([15786,15726,15849,16580],0); -ELEMENTS[65764] = Fluid3D([4701,4558,4183,3893],0); -ELEMENTS[65765] = Fluid3D([6495,5952,5803,5742],0); -ELEMENTS[65766] = Fluid3D([8250,7836,8692,7556],0); -ELEMENTS[65767] = Fluid3D([12841,13312,12368,12069],0); -ELEMENTS[65768] = Fluid3D([12368,12841,12069,11930],0); -ELEMENTS[65769] = Fluid3D([6051,5871,5839,6432],0); -ELEMENTS[65770] = Fluid3D([4950,5546,5043,4916],0); -ELEMENTS[65771] = Fluid3D([4105,4011,3662,3553],0); -ELEMENTS[65772] = Fluid3D([9544,10240,9459,9785],0); -ELEMENTS[65773] = Fluid3D([9459,9544,9785,8635],0); -ELEMENTS[65774] = Fluid3D([9785,9459,8635,9260],0); -ELEMENTS[65775] = Fluid3D([8633,8070,9153,9231],0); -ELEMENTS[65776] = Fluid3D([9153,8633,9231,9885],0); -ELEMENTS[65777] = Fluid3D([5366,5064,5511,5784],0); -ELEMENTS[65778] = Fluid3D([8176,7806,7133,7608],0); -ELEMENTS[65779] = Fluid3D([8345,9110,8306,9477],0); -ELEMENTS[65780] = Fluid3D([4081,4007,3570,3476],0); -ELEMENTS[65781] = Fluid3D([17188,17377,17476,16931],0); -ELEMENTS[65782] = Fluid3D([1610,1553,1546,1664],0); -ELEMENTS[65783] = Fluid3D([1610,1553,1664,1621],0); -ELEMENTS[65784] = Fluid3D([1553,1664,1621,1625],0); -ELEMENTS[65785] = Fluid3D([1553,1664,1625,1546],0); -ELEMENTS[65786] = Fluid3D([1664,1610,1621,1698],0); -ELEMENTS[65787] = Fluid3D([1664,1621,1625,1723],0); -ELEMENTS[65788] = Fluid3D([1625,1664,1723,1791],0); -ELEMENTS[65789] = Fluid3D([1664,1723,1791,1621],0); -ELEMENTS[65790] = Fluid3D([16004,15642,16254,16145],0); -ELEMENTS[65791] = Fluid3D([17409,17734,17605,17535],0); -ELEMENTS[65792] = Fluid3D([13881,14202,13125,13505],0); -ELEMENTS[65793] = Fluid3D([10772,9676,9442,10115],0); -ELEMENTS[65794] = Fluid3D([9865,9200,9355,9084],0); -ELEMENTS[65795] = Fluid3D([9427,8837,9247,9556],0); -ELEMENTS[65796] = Fluid3D([18192,18223,18379,18441],0); -ELEMENTS[65797] = Fluid3D([6647,6406,6068,5969],0); -ELEMENTS[65798] = Fluid3D([16161,15818,15535,15732],0); -ELEMENTS[65799] = Fluid3D([11533,11237,10627,11634],0); -ELEMENTS[65800] = Fluid3D([6771,7605,7105,7318],0); -ELEMENTS[65801] = Fluid3D([13578,13219,13999,13293],0); -ELEMENTS[65802] = Fluid3D([13578,13219,13293,12674],0); -ELEMENTS[65803] = Fluid3D([13219,13293,12674,13276],0); -ELEMENTS[65804] = Fluid3D([13293,12674,13276,13518],0); -ELEMENTS[65805] = Fluid3D([13219,13999,13293,13276],0); -ELEMENTS[65806] = Fluid3D([13999,13293,13276,13518],0); -ELEMENTS[65807] = Fluid3D([13293,13578,12674,13693],0); -ELEMENTS[65808] = Fluid3D([13293,13578,13693,13999],0); -ELEMENTS[65809] = Fluid3D([12674,13293,13693,13518],0); -ELEMENTS[65810] = Fluid3D([10001,10116,10921,11044],0); -ELEMENTS[65811] = Fluid3D([10921,10001,11044,10826],0); -ELEMENTS[65812] = Fluid3D([12247,13100,12573,13303],0); -ELEMENTS[65813] = Fluid3D([13619,13584,12644,13196],0); -ELEMENTS[65814] = Fluid3D([14882,14032,14685,14190],0); -ELEMENTS[65815] = Fluid3D([12036,12646,13097,12214],0); -ELEMENTS[65816] = Fluid3D([14482,14910,15147,15188],0); -ELEMENTS[65817] = Fluid3D([14482,14910,15188,14488],0); -ELEMENTS[65818] = Fluid3D([5856,5414,5920,5445],0); -ELEMENTS[65819] = Fluid3D([14265,13860,14747,13825],0); -ELEMENTS[65820] = Fluid3D([15141,15317,14915,15519],0); -ELEMENTS[65821] = Fluid3D([15141,15317,15519,15686],0); -ELEMENTS[65822] = Fluid3D([15141,15317,15686,15715],0); -ELEMENTS[65823] = Fluid3D([15772,16121,16064,15548],0); -ELEMENTS[65824] = Fluid3D([14638,14108,13704,14545],0); -ELEMENTS[65825] = Fluid3D([7166,7332,7746,7320],0); -ELEMENTS[65826] = Fluid3D([2352,2593,2480,2466],0); -ELEMENTS[65827] = Fluid3D([16099,16055,16614,16607],0); -ELEMENTS[65828] = Fluid3D([5261,5757,5152,5017],0); -ELEMENTS[65829] = Fluid3D([16380,16624,16818,17108],0); -ELEMENTS[65830] = Fluid3D([10077,10229,10969,9367],0); -ELEMENTS[65831] = Fluid3D([13295,12677,12325,13051],0); -ELEMENTS[65832] = Fluid3D([13295,12677,13051,12261],0); -ELEMENTS[65833] = Fluid3D([12677,12325,13051,12224],0); -ELEMENTS[65834] = Fluid3D([8923,9382,9870,10072],0); -ELEMENTS[65835] = Fluid3D([6006,6138,6709,6100],0); -ELEMENTS[65836] = Fluid3D([12830,13350,12849,13701],0); -ELEMENTS[65837] = Fluid3D([13350,12849,13701,14049],0); -ELEMENTS[65838] = Fluid3D([13701,13350,14049,14546],0); -ELEMENTS[65839] = Fluid3D([13701,13350,14546,13603],0); -ELEMENTS[65840] = Fluid3D([2713,2555,2512,2943],0); -ELEMENTS[65841] = Fluid3D([10258,9306,9958,10660],0); -ELEMENTS[65842] = Fluid3D([9958,10258,10660,11168],0); -ELEMENTS[65843] = Fluid3D([5379,5705,5142,4873],0); -ELEMENTS[65844] = Fluid3D([5116,5294,5616,5144],0); -ELEMENTS[65845] = Fluid3D([2581,2379,2450,2340],0); -ELEMENTS[65846] = Fluid3D([18532,18585,18579,18632],0); -ELEMENTS[65847] = Fluid3D([18532,18585,18632,18608],0); -ELEMENTS[65848] = Fluid3D([14576,14343,15057,15375],0); -ELEMENTS[65849] = Fluid3D([7734,8734,7811,8385],0); -ELEMENTS[65850] = Fluid3D([5798,5602,6251,6248],0); -ELEMENTS[65851] = Fluid3D([3074,2843,2932,2610],0); -ELEMENTS[65852] = Fluid3D([11855,10875,11420,11798],0); -ELEMENTS[65853] = Fluid3D([12388,12311,12924,11935],0); -ELEMENTS[65854] = Fluid3D([12311,12924,11935,12925],0); -ELEMENTS[65855] = Fluid3D([11935,12311,12925,12033],0); -ELEMENTS[65856] = Fluid3D([8154,7312,7644,8103],0); -ELEMENTS[65857] = Fluid3D([7644,8154,8103,8927],0); -ELEMENTS[65858] = Fluid3D([3425,3616,3360,3049],0); -ELEMENTS[65859] = Fluid3D([4490,4040,4129,4542],0); -ELEMENTS[65860] = Fluid3D([8648,8323,8379,7418],0); -ELEMENTS[65861] = Fluid3D([9549,9294,8910,9756],0); -ELEMENTS[65862] = Fluid3D([9225,8784,8821,9421],0); -ELEMENTS[65863] = Fluid3D([8382,8104,8330,7495],0); -ELEMENTS[65864] = Fluid3D([8382,8104,7495,7059],0); -ELEMENTS[65865] = Fluid3D([14262,13670,14476,14649],0); -ELEMENTS[65866] = Fluid3D([14197,14473,13922,13602],0); -ELEMENTS[65867] = Fluid3D([13922,14197,13602,12851],0); -ELEMENTS[65868] = Fluid3D([18315,18392,18512,18443],0); -ELEMENTS[65869] = Fluid3D([16925,16441,16706,16405],0); -ELEMENTS[65870] = Fluid3D([10407,9911,10432,11118],0); -ELEMENTS[65871] = Fluid3D([10760,9887,10569,10425],0); -ELEMENTS[65872] = Fluid3D([10760,9887,10425,10540],0); -ELEMENTS[65873] = Fluid3D([10425,10760,10540,11366],0); -ELEMENTS[65874] = Fluid3D([10760,10540,11366,11807],0); -ELEMENTS[65875] = Fluid3D([11366,10760,11807,11972],0); -ELEMENTS[65876] = Fluid3D([10425,10760,11366,10569],0); -ELEMENTS[65877] = Fluid3D([10760,11366,10569,11225],0); -ELEMENTS[65878] = Fluid3D([10760,11366,11225,11972],0); -ELEMENTS[65879] = Fluid3D([8496,9231,9602,9151],0); -ELEMENTS[65880] = Fluid3D([9602,8496,9151,9109],0); -ELEMENTS[65881] = Fluid3D([13928,13485,13494,14315],0); -ELEMENTS[65882] = Fluid3D([13485,13494,14315,13720],0); -ELEMENTS[65883] = Fluid3D([6861,7610,6302,7250],0); -ELEMENTS[65884] = Fluid3D([11979,11534,11339,11044],0); -ELEMENTS[65885] = Fluid3D([3956,3641,3868,3506],0); -ELEMENTS[65886] = Fluid3D([3641,3868,3506,3320],0); -ELEMENTS[65887] = Fluid3D([3904,3565,3320,3700],0); -ELEMENTS[65888] = Fluid3D([3904,3565,3700,4296],0); -ELEMENTS[65889] = Fluid3D([12527,13277,12611,13173],0); -ELEMENTS[65890] = Fluid3D([5626,5479,5093,5713],0); -ELEMENTS[65891] = Fluid3D([3237,3617,3605,3129],0); -ELEMENTS[65892] = Fluid3D([9662,8755,10344,8866],0); -ELEMENTS[65893] = Fluid3D([3903,4294,4297,4281],0); -ELEMENTS[65894] = Fluid3D([7928,7197,6960,7354],0); -ELEMENTS[65895] = Fluid3D([7928,7197,7354,7950],0); -ELEMENTS[65896] = Fluid3D([16936,16548,17008,17185],0); -ELEMENTS[65897] = Fluid3D([6012,6348,5658,5700],0); -ELEMENTS[65898] = Fluid3D([6012,6348,5700,6043],0); -ELEMENTS[65899] = Fluid3D([10689,10704,9725,10815],0); -ELEMENTS[65900] = Fluid3D([10689,10704,10815,11781],0); -ELEMENTS[65901] = Fluid3D([14677,14967,14184,14192],0); -ELEMENTS[65902] = Fluid3D([2514,2318,2272,2365],0); -ELEMENTS[65903] = Fluid3D([7784,8226,8471,9179],0); -ELEMENTS[65904] = Fluid3D([5986,5950,5680,6366],0); -ELEMENTS[65905] = Fluid3D([8368,8855,9030,7993],0); -ELEMENTS[65906] = Fluid3D([8855,9030,7993,8768],0); -ELEMENTS[65907] = Fluid3D([8855,9030,8768,9241],0); -ELEMENTS[65908] = Fluid3D([8368,8855,7993,7611],0); -ELEMENTS[65909] = Fluid3D([8855,7993,7611,8768],0); -ELEMENTS[65910] = Fluid3D([7993,8368,7611,7374],0); -ELEMENTS[65911] = Fluid3D([7611,7993,7374,7508],0); -ELEMENTS[65912] = Fluid3D([9030,7993,8768,7814],0); -ELEMENTS[65913] = Fluid3D([7993,8368,7374,7508],0); -ELEMENTS[65914] = Fluid3D([15369,15045,15628,15099],0); -ELEMENTS[65915] = Fluid3D([6662,6636,6306,7347],0); -ELEMENTS[65916] = Fluid3D([6306,6662,7347,7087],0); -ELEMENTS[65917] = Fluid3D([8169,8187,7569,8333],0); -ELEMENTS[65918] = Fluid3D([7713,7491,7898,8220],0); -ELEMENTS[65919] = Fluid3D([7713,7491,8220,7572],0); -ELEMENTS[65920] = Fluid3D([8220,7713,7572,6893],0); -ELEMENTS[65921] = Fluid3D([7713,7491,7572,6862],0); -ELEMENTS[65922] = Fluid3D([11095,11899,12015,11475],0); -ELEMENTS[65923] = Fluid3D([15065,14893,14608,15535],0); -ELEMENTS[65924] = Fluid3D([3666,3376,3300,3331],0); -ELEMENTS[65925] = Fluid3D([12025,11102,11201,12106],0); -ELEMENTS[65926] = Fluid3D([11102,11201,12106,11436],0); -ELEMENTS[65927] = Fluid3D([12025,11102,12106,11513],0); -ELEMENTS[65928] = Fluid3D([13262,13231,13314,12324],0); -ELEMENTS[65929] = Fluid3D([16051,15747,16258,16374],0); -ELEMENTS[65930] = Fluid3D([16051,15747,16374,16158],0); -ELEMENTS[65931] = Fluid3D([17284,16872,17231,17235],0); -ELEMENTS[65932] = Fluid3D([12430,13301,13710,12857],0); -ELEMENTS[65933] = Fluid3D([13429,14064,12901,12896],0); -ELEMENTS[65934] = Fluid3D([12901,13429,12896,12887],0); -ELEMENTS[65935] = Fluid3D([13429,14064,12896,13711],0); -ELEMENTS[65936] = Fluid3D([12896,13429,13711,13807],0); -ELEMENTS[65937] = Fluid3D([13429,12896,12887,13321],0); -ELEMENTS[65938] = Fluid3D([13429,12896,13321,13807],0); -ELEMENTS[65939] = Fluid3D([17952,17868,17843,18057],0); -ELEMENTS[65940] = Fluid3D([16304,15795,16411,16239],0); -ELEMENTS[65941] = Fluid3D([16731,17053,16868,16624],0); -ELEMENTS[65942] = Fluid3D([4959,5051,4727,4994],0); -ELEMENTS[65943] = Fluid3D([4727,4959,4994,5508],0); -ELEMENTS[65944] = Fluid3D([4959,5051,4994,5555],0); -ELEMENTS[65945] = Fluid3D([16741,16892,17048,16561],0); -ELEMENTS[65946] = Fluid3D([6606,7212,7032,6258],0); -ELEMENTS[65947] = Fluid3D([16225,16482,15814,16088],0); -ELEMENTS[65948] = Fluid3D([16482,15814,16088,16590],0); -ELEMENTS[65949] = Fluid3D([10023,10209,10042,9096],0); -ELEMENTS[65950] = Fluid3D([10419,9959,9766,9893],0); -ELEMENTS[65951] = Fluid3D([7367,6965,7478,7513],0); -ELEMENTS[65952] = Fluid3D([4296,4753,4767,4351],0); -ELEMENTS[65953] = Fluid3D([7742,7773,8596,8324],0); -ELEMENTS[65954] = Fluid3D([7742,7773,8324,8010],0); -ELEMENTS[65955] = Fluid3D([10043,10957,10612,11286],0); -ELEMENTS[65956] = Fluid3D([10043,10957,11286,10527],0); -ELEMENTS[65957] = Fluid3D([10957,10612,11286,11820],0); -ELEMENTS[65958] = Fluid3D([3256,3583,3639,3638],0); -ELEMENTS[65959] = Fluid3D([9215,9527,8426,9129],0); -ELEMENTS[65960] = Fluid3D([13982,14129,13491,13400],0); -ELEMENTS[65961] = Fluid3D([13982,14129,13400,14412],0); -ELEMENTS[65962] = Fluid3D([11966,12251,12932,12310],0); -ELEMENTS[65963] = Fluid3D([9043,8743,9697,9919],0); -ELEMENTS[65964] = Fluid3D([8858,9439,9392,8614],0); -ELEMENTS[65965] = Fluid3D([2422,2404,2592,2739],0); -ELEMENTS[65966] = Fluid3D([15213,14863,14960,15683],0); -ELEMENTS[65967] = Fluid3D([9173,10350,9598,9728],0); -ELEMENTS[65968] = Fluid3D([18412,18215,18378,18297],0); -ELEMENTS[65969] = Fluid3D([16177,16539,16230,15717],0); -ELEMENTS[65970] = Fluid3D([15091,15617,15378,15136],0); -ELEMENTS[65971] = Fluid3D([16499,16608,16097,16381],0); -ELEMENTS[65972] = Fluid3D([15482,15861,15071,15924],0); -ELEMENTS[65973] = Fluid3D([14649,15353,14849,14555],0); -ELEMENTS[65974] = Fluid3D([2775,2805,2652,3124],0); -ELEMENTS[65975] = Fluid3D([11006,10709,11830,11206],0); -ELEMENTS[65976] = Fluid3D([6814,6656,6617,5959],0); -ELEMENTS[65977] = Fluid3D([6814,6656,5959,6143],0); -ELEMENTS[65978] = Fluid3D([6814,6656,6143,6740],0); -ELEMENTS[65979] = Fluid3D([6656,5959,6143,5895],0); -ELEMENTS[65980] = Fluid3D([6428,6988,6520,6184],0); -ELEMENTS[65981] = Fluid3D([6428,6988,6184,6898],0); -ELEMENTS[65982] = Fluid3D([6988,6184,6898,6479],0); -ELEMENTS[65983] = Fluid3D([6988,6184,6479,7025],0); -ELEMENTS[65984] = Fluid3D([11575,12499,12624,11866],0); -ELEMENTS[65985] = Fluid3D([8424,8444,8382,9111],0); -ELEMENTS[65986] = Fluid3D([16618,16896,16189,16799],0); -ELEMENTS[65987] = Fluid3D([6222,6679,6706,6900],0); -ELEMENTS[65988] = Fluid3D([18044,18088,17752,18081],0); -ELEMENTS[65989] = Fluid3D([15985,15523,15716,16269],0); -ELEMENTS[65990] = Fluid3D([5279,5673,5402,4952],0); -ELEMENTS[65991] = Fluid3D([14546,14664,15293,14310],0); -ELEMENTS[65992] = Fluid3D([17599,17655,17628,17214],0); -ELEMENTS[65993] = Fluid3D([13477,13787,12859,13747],0); -ELEMENTS[65994] = Fluid3D([7492,7725,6750,6900],0); -ELEMENTS[65995] = Fluid3D([7492,7725,6900,7826],0); -ELEMENTS[65996] = Fluid3D([13446,14229,14571,13329],0); -ELEMENTS[65997] = Fluid3D([11205,12103,11833,12072],0); -ELEMENTS[65998] = Fluid3D([4991,5045,5144,5790],0); -ELEMENTS[65999] = Fluid3D([5331,5603,4989,4741],0); -ELEMENTS[66000] = Fluid3D([14950,14337,15097,14555],0); -ELEMENTS[66001] = Fluid3D([8657,8518,9285,9653],0); -ELEMENTS[66002] = Fluid3D([9017,9416,9176,10182],0); -ELEMENTS[66003] = Fluid3D([6586,6399,5791,5976],0); -ELEMENTS[66004] = Fluid3D([16726,16368,16365,16570],0); -ELEMENTS[66005] = Fluid3D([16254,16229,16606,16145],0); -ELEMENTS[66006] = Fluid3D([12911,13106,13466,12038],0); -ELEMENTS[66007] = Fluid3D([16572,16347,16311,15876],0); -ELEMENTS[66008] = Fluid3D([9690,9773,9293,10755],0); -ELEMENTS[66009] = Fluid3D([17063,16686,16613,17057],0); -ELEMENTS[66010] = Fluid3D([9072,8404,8330,7892],0); -ELEMENTS[66011] = Fluid3D([10051,9913,9589,10678],0); -ELEMENTS[66012] = Fluid3D([14071,13261,13964,13277],0); -ELEMENTS[66013] = Fluid3D([7348,7566,8143,7213],0); -ELEMENTS[66014] = Fluid3D([17896,17947,17645,17770],0); -ELEMENTS[66015] = Fluid3D([5666,5490,6113,5719],0); -ELEMENTS[66016] = Fluid3D([7841,7317,7838,7035],0); -ELEMENTS[66017] = Fluid3D([6869,7040,7431,7712],0); -ELEMENTS[66018] = Fluid3D([6139,6814,6143,6740],0); -ELEMENTS[66019] = Fluid3D([6018,5821,6531,7031],0); -ELEMENTS[66020] = Fluid3D([9145,9378,8498,8871],0); -ELEMENTS[66021] = Fluid3D([15260,15748,14825,15314],0); -ELEMENTS[66022] = Fluid3D([13614,13933,13790,12657],0); -ELEMENTS[66023] = Fluid3D([5679,5218,5194,5075],0); -ELEMENTS[66024] = Fluid3D([10859,11760,11009,11204],0); -ELEMENTS[66025] = Fluid3D([5472,5512,5058,5929],0); -ELEMENTS[66026] = Fluid3D([11996,12541,11894,12652],0); -ELEMENTS[66027] = Fluid3D([11894,11996,12652,11583],0); -ELEMENTS[66028] = Fluid3D([11124,11870,11016,11709],0); -ELEMENTS[66029] = Fluid3D([11124,11870,11709,11908],0); -ELEMENTS[66030] = Fluid3D([13720,12943,13485,13161],0); -ELEMENTS[66031] = Fluid3D([13491,13962,14318,14129],0); -ELEMENTS[66032] = Fluid3D([14318,13491,14129,13910],0); -ELEMENTS[66033] = Fluid3D([7815,7368,7413,8396],0); -ELEMENTS[66034] = Fluid3D([14812,14147,14491,14686],0); -ELEMENTS[66035] = Fluid3D([7941,8353,7621,7189],0); -ELEMENTS[66036] = Fluid3D([16567,16287,16377,16046],0); -ELEMENTS[66037] = Fluid3D([8997,9074,7849,8478],0); -ELEMENTS[66038] = Fluid3D([16319,16631,16970,16968],0); -ELEMENTS[66039] = Fluid3D([14087,14561,15015,14437],0); -ELEMENTS[66040] = Fluid3D([3550,3435,3523,3911],0); -ELEMENTS[66041] = Fluid3D([3550,3435,3911,3752],0); -ELEMENTS[66042] = Fluid3D([9410,9755,9204,10178],0); -ELEMENTS[66043] = Fluid3D([7585,7825,8519,8583],0); -ELEMENTS[66044] = Fluid3D([10824,10364,9950,9604],0); -ELEMENTS[66045] = Fluid3D([11924,11520,12062,10961],0); -ELEMENTS[66046] = Fluid3D([5031,4650,4850,4314],0); -ELEMENTS[66047] = Fluid3D([5031,4650,4314,4752],0); -ELEMENTS[66048] = Fluid3D([6677,5808,6619,5830],0); -ELEMENTS[66049] = Fluid3D([17242,17296,17674,17322],0); -ELEMENTS[66050] = Fluid3D([17674,17242,17322,17570],0); -ELEMENTS[66051] = Fluid3D([11433,12531,11983,11891],0); -ELEMENTS[66052] = Fluid3D([3990,4009,4443,3966],0); -ELEMENTS[66053] = Fluid3D([4009,4443,3966,4437],0); -ELEMENTS[66054] = Fluid3D([4443,3966,4437,4112],0); -ELEMENTS[66055] = Fluid3D([15979,16072,16254,16536],0); -ELEMENTS[66056] = Fluid3D([15979,16072,16536,16453],0); -ELEMENTS[66057] = Fluid3D([13754,12922,12737,13177],0); -ELEMENTS[66058] = Fluid3D([5856,6304,6054,6769],0); -ELEMENTS[66059] = Fluid3D([4992,4999,4288,4733],0); -ELEMENTS[66060] = Fluid3D([4992,4999,4733,5611],0); -ELEMENTS[66061] = Fluid3D([4992,4999,5611,5663],0); -ELEMENTS[66062] = Fluid3D([8743,8926,9351,8665],0); -ELEMENTS[66063] = Fluid3D([8926,9351,8665,8389],0); -ELEMENTS[66064] = Fluid3D([8926,9351,8389,9573],0); -ELEMENTS[66065] = Fluid3D([15260,14786,15004,15662],0); -ELEMENTS[66066] = Fluid3D([13200,13647,14184,14487],0); -ELEMENTS[66067] = Fluid3D([10599,10178,10696,9410],0); -ELEMENTS[66068] = Fluid3D([3666,3812,4071,4126],0); -ELEMENTS[66069] = Fluid3D([4071,3666,4126,3673],0); -ELEMENTS[66070] = Fluid3D([3666,3812,4126,3530],0); -ELEMENTS[66071] = Fluid3D([14077,14144,13333,13652],0); -ELEMENTS[66072] = Fluid3D([15038,14871,14935,15708],0); -ELEMENTS[66073] = Fluid3D([15145,14421,15016,14354],0); -ELEMENTS[66074] = Fluid3D([14421,15016,14354,14454],0); -ELEMENTS[66075] = Fluid3D([15145,14421,14354,15021],0); -ELEMENTS[66076] = Fluid3D([18494,18438,18288,18222],0); -ELEMENTS[66077] = Fluid3D([11944,12655,11891,12156],0); -ELEMENTS[66078] = Fluid3D([14131,13668,13563,14397],0); -ELEMENTS[66079] = Fluid3D([14131,13668,14397,14539],0); -ELEMENTS[66080] = Fluid3D([15690,15632,16190,15405],0); -ELEMENTS[66081] = Fluid3D([14033,14579,13915,14487],0); -ELEMENTS[66082] = Fluid3D([13771,14270,14148,14674],0); -ELEMENTS[66083] = Fluid3D([13378,12445,12903,12293],0); -ELEMENTS[66084] = Fluid3D([5449,5088,5612,5409],0); -ELEMENTS[66085] = Fluid3D([1816,1875,1717,1861],0); -ELEMENTS[66086] = Fluid3D([7628,7705,6892,7501],0); -ELEMENTS[66087] = Fluid3D([2301,2179,2406,2381],0); -ELEMENTS[66088] = Fluid3D([16473,16849,16662,17039],0); -ELEMENTS[66089] = Fluid3D([18677,18689,18693,18671],0); -ELEMENTS[66090] = Fluid3D([10325,9708,10359,9901],0); -ELEMENTS[66091] = Fluid3D([10325,9708,9901,9259],0); -ELEMENTS[66092] = Fluid3D([18313,18296,18114,18062],0); -ELEMENTS[66093] = Fluid3D([18296,18114,18062,18213],0); -ELEMENTS[66094] = Fluid3D([18296,18114,18213,18388],0); -ELEMENTS[66095] = Fluid3D([18250,18200,18044,18277],0); -ELEMENTS[66096] = Fluid3D([6651,6345,7168,6385],0); -ELEMENTS[66097] = Fluid3D([6651,6345,6385,5964],0); -ELEMENTS[66098] = Fluid3D([7429,7744,8179,8853],0); -ELEMENTS[66099] = Fluid3D([4700,4662,5401,5206],0); -ELEMENTS[66100] = Fluid3D([17554,17720,17866,17860],0); -ELEMENTS[66101] = Fluid3D([3527,3862,3460,3593],0); -ELEMENTS[66102] = Fluid3D([9429,9213,9183,9909],0); -ELEMENTS[66103] = Fluid3D([13949,13476,12756,13741],0); -ELEMENTS[66104] = Fluid3D([17348,17629,17589,17041],0); -ELEMENTS[66105] = Fluid3D([12514,11855,11698,12152],0); -ELEMENTS[66106] = Fluid3D([3666,3631,3300,3673],0); -ELEMENTS[66107] = Fluid3D([10327,10373,11330,10743],0); -ELEMENTS[66108] = Fluid3D([9747,9602,10882,10652],0); -ELEMENTS[66109] = Fluid3D([1723,1641,1712,1621],0); -ELEMENTS[66110] = Fluid3D([5368,4924,5506,5490],0); -ELEMENTS[66111] = Fluid3D([5174,4654,4574,4893],0); -ELEMENTS[66112] = Fluid3D([4574,5174,4893,5564],0); -ELEMENTS[66113] = Fluid3D([14279,13771,13851,14674],0); -ELEMENTS[66114] = Fluid3D([13771,13851,14674,14148],0); -ELEMENTS[66115] = Fluid3D([2469,2890,2729,2649],0); -ELEMENTS[66116] = Fluid3D([12881,12441,12001,11387],0); -ELEMENTS[66117] = Fluid3D([5644,6228,5928,5432],0); -ELEMENTS[66118] = Fluid3D([15677,15386,14877,15502],0); -ELEMENTS[66119] = Fluid3D([15287,15804,16129,15723],0); -ELEMENTS[66120] = Fluid3D([2799,2778,2503,2681],0); -ELEMENTS[66121] = Fluid3D([2799,2778,2681,3138],0); -ELEMENTS[66122] = Fluid3D([2503,2799,2681,2431],0); -ELEMENTS[66123] = Fluid3D([2799,2681,2431,2852],0); -ELEMENTS[66124] = Fluid3D([2799,2681,2852,3138],0); -ELEMENTS[66125] = Fluid3D([18153,17821,17938,18078],0); -ELEMENTS[66126] = Fluid3D([7815,8469,8811,7842],0); -ELEMENTS[66127] = Fluid3D([12830,13350,13701,13603],0); -ELEMENTS[66128] = Fluid3D([3744,4035,3801,4204],0); -ELEMENTS[66129] = Fluid3D([3801,3744,4204,3783],0); -ELEMENTS[66130] = Fluid3D([13554,13588,12635,13051],0); -ELEMENTS[66131] = Fluid3D([17551,17928,17644,17630],0); -ELEMENTS[66132] = Fluid3D([3459,3795,3306,3780],0); -ELEMENTS[66133] = Fluid3D([10074,10248,9271,9437],0); -ELEMENTS[66134] = Fluid3D([17278,16694,17077,16795],0); -ELEMENTS[66135] = Fluid3D([3819,4005,3883,3720],0); -ELEMENTS[66136] = Fluid3D([13104,13039,12416,11993],0); -ELEMENTS[66137] = Fluid3D([7672,8593,7820,7640],0); -ELEMENTS[66138] = Fluid3D([13345,14062,13898,13704],0); -ELEMENTS[66139] = Fluid3D([6320,5780,5924,6114],0); -ELEMENTS[66140] = Fluid3D([5924,6320,6114,6997],0); -ELEMENTS[66141] = Fluid3D([6114,5924,6997,6661],0); -ELEMENTS[66142] = Fluid3D([5780,5924,6114,5486],0); -ELEMENTS[66143] = Fluid3D([5924,6114,5486,5798],0); -ELEMENTS[66144] = Fluid3D([5924,6114,5798,6661],0); -ELEMENTS[66145] = Fluid3D([6114,5486,5798,6248],0); -ELEMENTS[66146] = Fluid3D([5798,6114,6248,6661],0); -ELEMENTS[66147] = Fluid3D([6114,5780,5486,6248],0); -ELEMENTS[66148] = Fluid3D([4345,4036,4589,4419],0); -ELEMENTS[66149] = Fluid3D([13403,13475,13083,12301],0); -ELEMENTS[66150] = Fluid3D([13475,13083,12301,12737],0); -ELEMENTS[66151] = Fluid3D([16306,16203,16475,16174],0); -ELEMENTS[66152] = Fluid3D([16475,16306,16174,15749],0); -ELEMENTS[66153] = Fluid3D([16306,16203,16174,15582],0); -ELEMENTS[66154] = Fluid3D([1976,2037,1873,1809],0); -ELEMENTS[66155] = Fluid3D([15331,14885,15451,15543],0); -ELEMENTS[66156] = Fluid3D([3661,3559,3916,4202],0); -ELEMENTS[66157] = Fluid3D([3661,3559,4202,3940],0); -ELEMENTS[66158] = Fluid3D([18458,18519,18597,18421],0); -ELEMENTS[66159] = Fluid3D([15568,15977,16327,15715],0); -ELEMENTS[66160] = Fluid3D([5114,5593,4873,5620],0); -ELEMENTS[66161] = Fluid3D([18108,17992,18170,18209],0); -ELEMENTS[66162] = Fluid3D([14632,15125,15334,15257],0); -ELEMENTS[66163] = Fluid3D([4822,4308,4306,4922],0); -ELEMENTS[66164] = Fluid3D([4822,4308,4922,4357],0); -ELEMENTS[66165] = Fluid3D([12540,12026,12464,12998],0); -ELEMENTS[66166] = Fluid3D([8411,7657,8007,7871],0); -ELEMENTS[66167] = Fluid3D([8411,7657,7871,8863],0); -ELEMENTS[66168] = Fluid3D([7657,8007,7871,6910],0); -ELEMENTS[66169] = Fluid3D([4464,4501,4302,4889],0); -ELEMENTS[66170] = Fluid3D([16841,16457,16478,16403],0); -ELEMENTS[66171] = Fluid3D([16841,16457,16403,17015],0); -ELEMENTS[66172] = Fluid3D([11798,12101,11855,11045],0); -ELEMENTS[66173] = Fluid3D([14867,15474,15538,15455],0); -ELEMENTS[66174] = Fluid3D([3084,3195,2781,3239],0); -ELEMENTS[66175] = Fluid3D([3084,3195,3239,3530],0); -ELEMENTS[66176] = Fluid3D([3195,3239,3530,3163],0); -ELEMENTS[66177] = Fluid3D([3195,3239,3163,2866],0); -ELEMENTS[66178] = Fluid3D([14740,15383,15529,15392],0); -ELEMENTS[66179] = Fluid3D([18123,18217,18198,17951],0); -ELEMENTS[66180] = Fluid3D([16415,16341,16525,16362],0); -ELEMENTS[66181] = Fluid3D([11188,11559,10370,10782],0); -ELEMENTS[66182] = Fluid3D([11188,11559,10782,11732],0); -ELEMENTS[66183] = Fluid3D([11559,10782,11732,11955],0); -ELEMENTS[66184] = Fluid3D([13412,13483,13172,12448],0); -ELEMENTS[66185] = Fluid3D([8207,8072,7610,7791],0); -ELEMENTS[66186] = Fluid3D([13077,12292,12327,11739],0); -ELEMENTS[66187] = Fluid3D([12292,12327,11739,11363],0); -ELEMENTS[66188] = Fluid3D([12353,12692,12170,12487],0); -ELEMENTS[66189] = Fluid3D([8441,8645,7886,9135],0); -ELEMENTS[66190] = Fluid3D([8483,8756,9223,8807],0); -ELEMENTS[66191] = Fluid3D([7357,7352,7747,6608],0); -ELEMENTS[66192] = Fluid3D([17473,17495,17254,16957],0); -ELEMENTS[66193] = Fluid3D([3932,3678,4185,4036],0); -ELEMENTS[66194] = Fluid3D([10005,10538,10469,11444],0); -ELEMENTS[66195] = Fluid3D([11326,10434,10606,11783],0); -ELEMENTS[66196] = Fluid3D([12087,12751,11272,11897],0); -ELEMENTS[66197] = Fluid3D([10194,10131,9549,11073],0); -ELEMENTS[66198] = Fluid3D([10225,9325,10188,10374],0); -ELEMENTS[66199] = Fluid3D([4475,3905,4619,4237],0); -ELEMENTS[66200] = Fluid3D([13606,14127,14376,14833],0); -ELEMENTS[66201] = Fluid3D([2823,2620,2547,2980],0); -ELEMENTS[66202] = Fluid3D([3934,3617,4086,4037],0); -ELEMENTS[66203] = Fluid3D([13913,14608,14519,14308],0); -ELEMENTS[66204] = Fluid3D([6031,5718,6166,5887],0); -ELEMENTS[66205] = Fluid3D([5354,5967,5708,5651],0); -ELEMENTS[66206] = Fluid3D([6901,6997,6899,6183],0); -ELEMENTS[66207] = Fluid3D([6901,6997,6183,5924],0); -ELEMENTS[66208] = Fluid3D([6183,6901,5924,6689],0); -ELEMENTS[66209] = Fluid3D([6901,6997,5924,6661],0); -ELEMENTS[66210] = Fluid3D([6997,6183,5924,6320],0); -ELEMENTS[66211] = Fluid3D([6183,5924,6320,5473],0); -ELEMENTS[66212] = Fluid3D([16925,16956,16579,16405],0); -ELEMENTS[66213] = Fluid3D([5538,5905,5886,5677],0); -ELEMENTS[66214] = Fluid3D([5886,5538,5677,4953],0); -ELEMENTS[66215] = Fluid3D([16864,16422,16339,16190],0); -ELEMENTS[66216] = Fluid3D([7691,7788,6902,8331],0); -ELEMENTS[66217] = Fluid3D([7691,7788,8331,8378],0); -ELEMENTS[66218] = Fluid3D([6748,6613,7168,6646],0); -ELEMENTS[66219] = Fluid3D([14182,13669,13471,14561],0); -ELEMENTS[66220] = Fluid3D([10122,10490,9376,10326],0); -ELEMENTS[66221] = Fluid3D([14381,14472,13598,13530],0); -ELEMENTS[66222] = Fluid3D([14381,14472,13530,14462],0); -ELEMENTS[66223] = Fluid3D([14381,14472,14462,14909],0); -ELEMENTS[66224] = Fluid3D([14381,14472,14909,15316],0); -ELEMENTS[66225] = Fluid3D([14472,14462,14909,14206],0); -ELEMENTS[66226] = Fluid3D([14462,14381,14909,15316],0); -ELEMENTS[66227] = Fluid3D([14909,14472,14206,15047],0); -ELEMENTS[66228] = Fluid3D([14462,14909,14206,15047],0); -ELEMENTS[66229] = Fluid3D([14462,14909,15047,15537],0); -ELEMENTS[66230] = Fluid3D([14909,14462,15316,15537],0); -ELEMENTS[66231] = Fluid3D([5956,5997,5342,6109],0); -ELEMENTS[66232] = Fluid3D([12546,12447,13421,13366],0); -ELEMENTS[66233] = Fluid3D([9882,10321,10467,11397],0); -ELEMENTS[66234] = Fluid3D([18079,18267,18408,18270],0); -ELEMENTS[66235] = Fluid3D([2006,1941,1821,1910],0); -ELEMENTS[66236] = Fluid3D([16263,16636,16984,16968],0); -ELEMENTS[66237] = Fluid3D([16636,16984,16968,17243],0); -ELEMENTS[66238] = Fluid3D([5770,6012,5700,6043],0); -ELEMENTS[66239] = Fluid3D([3371,3837,3608,3773],0); -ELEMENTS[66240] = Fluid3D([9126,8584,9506,9583],0); -ELEMENTS[66241] = Fluid3D([7851,7424,6969,6742],0); -ELEMENTS[66242] = Fluid3D([6099,5776,5729,5162],0); -ELEMENTS[66243] = Fluid3D([10850,10951,10181,11280],0); -ELEMENTS[66244] = Fluid3D([10951,10181,11280,11007],0); -ELEMENTS[66245] = Fluid3D([7258,8413,7860,8397],0); -ELEMENTS[66246] = Fluid3D([13777,14359,14373,14545],0); -ELEMENTS[66247] = Fluid3D([2577,2672,2932,2720],0); -ELEMENTS[66248] = Fluid3D([2577,2672,2720,2423],0); -ELEMENTS[66249] = Fluid3D([2672,2720,2423,2529],0); -ELEMENTS[66250] = Fluid3D([3082,3052,2943,2770],0); -ELEMENTS[66251] = Fluid3D([13668,13257,13563,12721],0); -ELEMENTS[66252] = Fluid3D([18368,18210,18401,18453],0); -ELEMENTS[66253] = Fluid3D([4635,4710,4953,5452],0); -ELEMENTS[66254] = Fluid3D([14372,14650,14780,14929],0); -ELEMENTS[66255] = Fluid3D([14780,14372,14929,13702],0); -ELEMENTS[66256] = Fluid3D([12106,12121,12025,12521],0); -ELEMENTS[66257] = Fluid3D([12025,12106,12521,13151],0); -ELEMENTS[66258] = Fluid3D([13477,13915,13263,14033],0); -ELEMENTS[66259] = Fluid3D([10599,11245,10550,10696],0); -ELEMENTS[66260] = Fluid3D([11390,11066,12093,11699],0); -ELEMENTS[66261] = Fluid3D([11066,12093,11699,11708],0); -ELEMENTS[66262] = Fluid3D([11699,11066,11708,10920],0); -ELEMENTS[66263] = Fluid3D([11699,11066,10920,10737],0); -ELEMENTS[66264] = Fluid3D([11699,11066,10737,11390],0); -ELEMENTS[66265] = Fluid3D([11066,11708,10920,10983],0); -ELEMENTS[66266] = Fluid3D([11066,11708,10983,12093],0); -ELEMENTS[66267] = Fluid3D([10918,11011,10803,11995],0); -ELEMENTS[66268] = Fluid3D([9745,10073,10428,9225],0); -ELEMENTS[66269] = Fluid3D([15414,16031,15633,15535],0); -ELEMENTS[66270] = Fluid3D([16031,15633,15535,16134],0); -ELEMENTS[66271] = Fluid3D([14847,15425,15719,15390],0); -ELEMENTS[66272] = Fluid3D([18466,18342,18461,18321],0); -ELEMENTS[66273] = Fluid3D([17417,17441,17431,17884],0); -ELEMENTS[66274] = Fluid3D([18447,18457,18523,18354],0); -ELEMENTS[66275] = Fluid3D([18402,18418,18433,18508],0); -ELEMENTS[66276] = Fluid3D([18418,18433,18508,18496],0); -ELEMENTS[66277] = Fluid3D([18508,18418,18496,18386],0); -ELEMENTS[66278] = Fluid3D([18508,18418,18386,18402],0); -ELEMENTS[66279] = Fluid3D([18418,18496,18386,18498],0); -ELEMENTS[66280] = Fluid3D([18496,18508,18386,18498],0); -ELEMENTS[66281] = Fluid3D([18418,18433,18496,18391],0); -ELEMENTS[66282] = Fluid3D([18433,18508,18496,18579],0); -ELEMENTS[66283] = Fluid3D([18508,18496,18579,18498],0); -ELEMENTS[66284] = Fluid3D([18496,18579,18498,18503],0); -ELEMENTS[66285] = Fluid3D([18418,18496,18498,18391],0); -ELEMENTS[66286] = Fluid3D([11034,10865,11257,12218],0); -ELEMENTS[66287] = Fluid3D([5612,5853,6390,6034],0); -ELEMENTS[66288] = Fluid3D([10766,10745,9931,10769],0); -ELEMENTS[66289] = Fluid3D([3817,4028,4196,3640],0); -ELEMENTS[66290] = Fluid3D([3817,4028,3640,3426],0); -ELEMENTS[66291] = Fluid3D([11722,11524,10500,11566],0); -ELEMENTS[66292] = Fluid3D([10349,10722,10193,11032],0); -ELEMENTS[66293] = Fluid3D([10349,10722,11032,11787],0); -ELEMENTS[66294] = Fluid3D([10193,10349,11032,10984],0); -ELEMENTS[66295] = Fluid3D([11032,10193,10984,11726],0); -ELEMENTS[66296] = Fluid3D([10349,11032,10984,11223],0); -ELEMENTS[66297] = Fluid3D([10349,11032,11223,11787],0); -ELEMENTS[66298] = Fluid3D([11032,11223,11787,10984],0); -ELEMENTS[66299] = Fluid3D([11787,11032,10984,11726],0); -ELEMENTS[66300] = Fluid3D([11787,11032,11726,10722],0); -ELEMENTS[66301] = Fluid3D([11032,11726,10722,10193],0); -ELEMENTS[66302] = Fluid3D([6370,7133,6779,6192],0); -ELEMENTS[66303] = Fluid3D([16802,16709,16197,16270],0); -ELEMENTS[66304] = Fluid3D([15392,15322,15937,16048],0); -ELEMENTS[66305] = Fluid3D([15954,15707,15757,15167],0); -ELEMENTS[66306] = Fluid3D([4061,3555,4053,3546],0); -ELEMENTS[66307] = Fluid3D([4863,4983,4673,5353],0); -ELEMENTS[66308] = Fluid3D([11292,10959,10384,12215],0); -ELEMENTS[66309] = Fluid3D([3629,3494,3926,4003],0); -ELEMENTS[66310] = Fluid3D([12936,12851,11890,12823],0); -ELEMENTS[66311] = Fluid3D([12936,12851,12823,13977],0); -ELEMENTS[66312] = Fluid3D([11890,12936,12823,12165],0); -ELEMENTS[66313] = Fluid3D([14863,14481,14960,13842],0); -ELEMENTS[66314] = Fluid3D([5006,4578,4718,5178],0); -ELEMENTS[66315] = Fluid3D([12832,12964,11941,12664],0); -ELEMENTS[66316] = Fluid3D([9612,9724,9418,10453],0); -ELEMENTS[66317] = Fluid3D([17317,17588,17301,17517],0); -ELEMENTS[66318] = Fluid3D([17588,17301,17517,17819],0); -ELEMENTS[66319] = Fluid3D([17317,17588,17517,17607],0); -ELEMENTS[66320] = Fluid3D([17588,17517,17607,17907],0); -ELEMENTS[66321] = Fluid3D([17517,17588,17819,17907],0); -ELEMENTS[66322] = Fluid3D([15136,14693,15015,15536],0); -ELEMENTS[66323] = Fluid3D([15136,14693,15536,15131],0); -ELEMENTS[66324] = Fluid3D([16210,16540,15826,16497],0); -ELEMENTS[66325] = Fluid3D([13040,12384,11776,12783],0); -ELEMENTS[66326] = Fluid3D([12955,12310,12114,11739],0); -ELEMENTS[66327] = Fluid3D([18190,18086,18004,17860],0); -ELEMENTS[66328] = Fluid3D([16265,16477,16502,15867],0); -ELEMENTS[66329] = Fluid3D([16477,16502,15867,15997],0); -ELEMENTS[66330] = Fluid3D([17582,17879,17706,17825],0); -ELEMENTS[66331] = Fluid3D([18037,17710,17940,18079],0); -ELEMENTS[66332] = Fluid3D([17940,18037,18079,18325],0); -ELEMENTS[66333] = Fluid3D([18037,17710,18079,17838],0); -ELEMENTS[66334] = Fluid3D([5107,5103,5657,5637],0); -ELEMENTS[66335] = Fluid3D([5107,5103,5637,5174],0); -ELEMENTS[66336] = Fluid3D([12573,13154,13100,12814],0); -ELEMENTS[66337] = Fluid3D([12573,13154,12814,12657],0); -ELEMENTS[66338] = Fluid3D([3492,3542,4009,3484],0); -ELEMENTS[66339] = Fluid3D([3492,3542,3484,3117],0); -ELEMENTS[66340] = Fluid3D([4775,4334,4241,4531],0); -ELEMENTS[66341] = Fluid3D([9687,9455,9754,8771],0); -ELEMENTS[66342] = Fluid3D([16800,17065,16849,17039],0); -ELEMENTS[66343] = Fluid3D([16109,15486,15992,15677],0); -ELEMENTS[66344] = Fluid3D([8299,8174,7326,8257],0); -ELEMENTS[66345] = Fluid3D([4810,4684,4743,4101],0); -ELEMENTS[66346] = Fluid3D([13835,13828,13952,14612],0); -ELEMENTS[66347] = Fluid3D([5822,6286,5864,6697],0); -ELEMENTS[66348] = Fluid3D([5944,5827,5363,6042],0); -ELEMENTS[66349] = Fluid3D([5821,5927,6531,6515],0); -ELEMENTS[66350] = Fluid3D([5821,5927,6515,5711],0); -ELEMENTS[66351] = Fluid3D([3367,3575,3071,3025],0); -ELEMENTS[66352] = Fluid3D([9442,9063,9348,10115],0); -ELEMENTS[66353] = Fluid3D([9063,9348,10115,9094],0); -ELEMENTS[66354] = Fluid3D([12445,12862,12598,12005],0); -ELEMENTS[66355] = Fluid3D([12445,12862,12005,12293],0); -ELEMENTS[66356] = Fluid3D([12005,12445,12293,11795],0); -ELEMENTS[66357] = Fluid3D([15239,15654,15698,16083],0); -ELEMENTS[66358] = Fluid3D([8699,9011,7966,7983],0); -ELEMENTS[66359] = Fluid3D([17560,17855,17805,17947],0); -ELEMENTS[66360] = Fluid3D([2555,2823,2501,2598],0); -ELEMENTS[66361] = Fluid3D([10948,11198,11470,12281],0); -ELEMENTS[66362] = Fluid3D([9119,8816,9463,8884],0); -ELEMENTS[66363] = Fluid3D([3066,3016,2813,3214],0); -ELEMENTS[66364] = Fluid3D([17154,17187,16619,17141],0); -ELEMENTS[66365] = Fluid3D([17154,17187,17141,17626],0); -ELEMENTS[66366] = Fluid3D([13402,13310,12444,12831],0); -ELEMENTS[66367] = Fluid3D([14638,14781,14545,13704],0); -ELEMENTS[66368] = Fluid3D([17804,17600,17451,17475],0); -ELEMENTS[66369] = Fluid3D([17600,17451,17475,17175],0); -ELEMENTS[66370] = Fluid3D([17724,17462,17567,17914],0); -ELEMENTS[66371] = Fluid3D([15186,15341,15438,15754],0); -ELEMENTS[66372] = Fluid3D([15186,15341,15754,15760],0); -ELEMENTS[66373] = Fluid3D([2739,2716,2783,2467],0); -ELEMENTS[66374] = Fluid3D([7217,6633,6265,7154],0); -ELEMENTS[66375] = Fluid3D([7217,6633,7154,7027],0); -ELEMENTS[66376] = Fluid3D([15791,15770,15386,15677],0); -ELEMENTS[66377] = Fluid3D([6757,6316,7158,6191],0); -ELEMENTS[66378] = Fluid3D([16753,16388,16456,15999],0); -ELEMENTS[66379] = Fluid3D([15366,15134,14559,15436],0); -ELEMENTS[66380] = Fluid3D([15720,15703,16229,16145],0); -ELEMENTS[66381] = Fluid3D([6140,6366,6641,5897],0); -ELEMENTS[66382] = Fluid3D([15521,15017,15441,14941],0); -ELEMENTS[66383] = Fluid3D([4103,3907,3745,3574],0); -ELEMENTS[66384] = Fluid3D([3907,3745,3574,3403],0); -ELEMENTS[66385] = Fluid3D([17251,16926,17080,17045],0); -ELEMENTS[66386] = Fluid3D([6353,5816,6728,6438],0); -ELEMENTS[66387] = Fluid3D([6244,5554,5546,5232],0); -ELEMENTS[66388] = Fluid3D([5477,5448,5006,5178],0); -ELEMENTS[66389] = Fluid3D([12323,11398,11816,11770],0); -ELEMENTS[66390] = Fluid3D([6563,6572,5945,5843],0); -ELEMENTS[66391] = Fluid3D([12065,11421,12466,12144],0); -ELEMENTS[66392] = Fluid3D([14706,14377,13872,13988],0); -ELEMENTS[66393] = Fluid3D([4741,4421,4478,4560],0); -ELEMENTS[66394] = Fluid3D([16267,15951,15660,15641],0); -ELEMENTS[66395] = Fluid3D([17985,17758,18027,17739],0); -ELEMENTS[66396] = Fluid3D([13986,13709,14649,14476],0); -ELEMENTS[66397] = Fluid3D([15058,15475,15316,15894],0); -ELEMENTS[66398] = Fluid3D([6989,6245,7377,7224],0); -ELEMENTS[66399] = Fluid3D([7377,6989,7224,7773],0); -ELEMENTS[66400] = Fluid3D([18068,17962,17880,17633],0); -ELEMENTS[66401] = Fluid3D([17880,18068,17633,17828],0); -ELEMENTS[66402] = Fluid3D([17633,17880,17828,17729],0); -ELEMENTS[66403] = Fluid3D([17880,18068,17828,18119],0); -ELEMENTS[66404] = Fluid3D([17633,17880,17729,17579],0); -ELEMENTS[66405] = Fluid3D([17880,17828,17729,17942],0); -ELEMENTS[66406] = Fluid3D([18068,17828,18119,17994],0); -ELEMENTS[66407] = Fluid3D([17828,18119,17994,17781],0); -ELEMENTS[66408] = Fluid3D([17828,18119,17781,17942],0); -ELEMENTS[66409] = Fluid3D([17781,17828,17942,17542],0); -ELEMENTS[66410] = Fluid3D([17781,17828,17542,17648],0); -ELEMENTS[66411] = Fluid3D([17994,17828,17781,17792],0); -ELEMENTS[66412] = Fluid3D([17994,17828,17792,18068],0); -ELEMENTS[66413] = Fluid3D([17792,17994,18068,18049],0); -ELEMENTS[66414] = Fluid3D([17792,17994,18049,18095],0); -ELEMENTS[66415] = Fluid3D([17792,17994,18095,17820],0); -ELEMENTS[66416] = Fluid3D([17792,17994,17820,17781],0); -ELEMENTS[66417] = Fluid3D([17994,18049,18095,18273],0); -ELEMENTS[66418] = Fluid3D([17994,18095,17820,18119],0); -ELEMENTS[66419] = Fluid3D([18095,17792,17820,17864],0); -ELEMENTS[66420] = Fluid3D([18095,17994,18273,18119],0); -ELEMENTS[66421] = Fluid3D([17820,17792,17781,17460],0); -ELEMENTS[66422] = Fluid3D([17820,17792,17460,17864],0); -ELEMENTS[66423] = Fluid3D([17994,18068,18049,18273],0); -ELEMENTS[66424] = Fluid3D([17994,17820,17781,18119],0); -ELEMENTS[66425] = Fluid3D([17828,17781,17792,17648],0); -ELEMENTS[66426] = Fluid3D([17792,17828,17648,18068],0); -ELEMENTS[66427] = Fluid3D([17994,18273,18119,18068],0); -ELEMENTS[66428] = Fluid3D([18049,17792,18095,17929],0); -ELEMENTS[66429] = Fluid3D([18049,17792,17929,17867],0); -ELEMENTS[66430] = Fluid3D([17929,18049,17867,18163],0); -ELEMENTS[66431] = Fluid3D([18049,17867,18163,18068],0); -ELEMENTS[66432] = Fluid3D([18095,18049,17929,18188],0); -ELEMENTS[66433] = Fluid3D([18049,17929,18188,18163],0); -ELEMENTS[66434] = Fluid3D([18095,18049,18188,18273],0); -ELEMENTS[66435] = Fluid3D([18163,18049,18068,18273],0); -ELEMENTS[66436] = Fluid3D([17828,18119,17942,17880],0); -ELEMENTS[66437] = Fluid3D([17633,17880,17579,17713],0); -ELEMENTS[66438] = Fluid3D([17740,17352,17627,17257],0); -ELEMENTS[66439] = Fluid3D([13266,13476,12756,13699],0); -ELEMENTS[66440] = Fluid3D([16014,16072,15979,16453],0); -ELEMENTS[66441] = Fluid3D([8424,7828,8444,8968],0); -ELEMENTS[66442] = Fluid3D([7490,7583,8509,7076],0); -ELEMENTS[66443] = Fluid3D([13805,14105,13277,13964],0); -ELEMENTS[66444] = Fluid3D([14969,15098,15186,15760],0); -ELEMENTS[66445] = Fluid3D([15958,15592,15598,15915],0); -ELEMENTS[66446] = Fluid3D([4733,4987,5234,5611],0); -ELEMENTS[66447] = Fluid3D([16287,15897,15596,16038],0); -ELEMENTS[66448] = Fluid3D([9393,10179,9819,10983],0); -ELEMENTS[66449] = Fluid3D([9075,9472,8913,8259],0); -ELEMENTS[66450] = Fluid3D([8913,9075,8259,9648],0); -ELEMENTS[66451] = Fluid3D([17977,18085,17715,17915],0); -ELEMENTS[66452] = Fluid3D([4290,4280,4769,4726],0); -ELEMENTS[66453] = Fluid3D([7974,7669,7127,7222],0); -ELEMENTS[66454] = Fluid3D([9674,9281,9851,10561],0); -ELEMENTS[66455] = Fluid3D([18207,18294,18063,18274],0); -ELEMENTS[66456] = Fluid3D([18063,18207,18274,18360],0); -ELEMENTS[66457] = Fluid3D([3747,3540,3434,3822],0); -ELEMENTS[66458] = Fluid3D([3434,3747,3822,3984],0); -ELEMENTS[66459] = Fluid3D([9958,10130,9923,11168],0); -ELEMENTS[66460] = Fluid3D([15279,15982,15601,15480],0); -ELEMENTS[66461] = Fluid3D([15279,15982,15480,16042],0); -ELEMENTS[66462] = Fluid3D([17904,17731,17671,18024],0); -ELEMENTS[66463] = Fluid3D([5296,5649,5834,5625],0); -ELEMENTS[66464] = Fluid3D([5834,5296,5625,5863],0); -ELEMENTS[66465] = Fluid3D([12115,11455,11685,12151],0); -ELEMENTS[66466] = Fluid3D([8265,7678,7427,7657],0); -ELEMENTS[66467] = Fluid3D([15226,14992,15001,14072],0); -ELEMENTS[66468] = Fluid3D([10914,11968,11883,11508],0); -ELEMENTS[66469] = Fluid3D([2964,2805,2817,3095],0); -ELEMENTS[66470] = Fluid3D([2964,2805,3095,3112],0); -ELEMENTS[66471] = Fluid3D([9188,9679,9829,9080],0); -ELEMENTS[66472] = Fluid3D([9679,9829,9080,9884],0); -ELEMENTS[66473] = Fluid3D([18198,18217,18356,18090],0); -ELEMENTS[66474] = Fluid3D([13350,13542,12849,14049],0); -ELEMENTS[66475] = Fluid3D([9481,10119,10789,10867],0); -ELEMENTS[66476] = Fluid3D([6796,6300,6966,6075],0); -ELEMENTS[66477] = Fluid3D([16792,17201,17331,17293],0); -ELEMENTS[66478] = Fluid3D([17201,17331,17293,17705],0); -ELEMENTS[66479] = Fluid3D([12676,13381,13116,13341],0); -ELEMENTS[66480] = Fluid3D([13381,13116,13341,14323],0); -ELEMENTS[66481] = Fluid3D([13261,13173,12113,12611],0); -ELEMENTS[66482] = Fluid3D([13261,13173,12611,13277],0); -ELEMENTS[66483] = Fluid3D([11356,11265,11296,10744],0); -ELEMENTS[66484] = Fluid3D([11265,11296,10744,11667],0); -ELEMENTS[66485] = Fluid3D([11296,11356,10744,10535],0); -ELEMENTS[66486] = Fluid3D([4528,4495,4262,3900],0); -ELEMENTS[66487] = Fluid3D([12236,12050,11708,13091],0); -ELEMENTS[66488] = Fluid3D([17098,17085,17364,17210],0); -ELEMENTS[66489] = Fluid3D([6802,6608,6093,6294],0); -ELEMENTS[66490] = Fluid3D([10752,10723,10753,11666],0); -ELEMENTS[66491] = Fluid3D([11811,11023,11417,10797],0); -ELEMENTS[66492] = Fluid3D([11417,11811,10797,12316],0); -ELEMENTS[66493] = Fluid3D([9293,9980,9690,10755],0); -ELEMENTS[66494] = Fluid3D([15859,16034,16478,16291],0); -ELEMENTS[66495] = Fluid3D([8784,8378,8821,8494],0); -ELEMENTS[66496] = Fluid3D([2179,2282,2046,2170],0); -ELEMENTS[66497] = Fluid3D([2046,2179,2170,1933],0); -ELEMENTS[66498] = Fluid3D([11794,11206,11254,10856],0); -ELEMENTS[66499] = Fluid3D([15496,16050,16168,15917],0); -ELEMENTS[66500] = Fluid3D([18220,18295,18355,18467],0); -ELEMENTS[66501] = Fluid3D([4546,4570,4742,4112],0); -ELEMENTS[66502] = Fluid3D([16074,15488,15655,15454],0); -ELEMENTS[66503] = Fluid3D([15655,16074,15454,15630],0); -ELEMENTS[66504] = Fluid3D([16074,15454,15630,15041],0); -ELEMENTS[66505] = Fluid3D([16074,15488,15454,15041],0); -ELEMENTS[66506] = Fluid3D([15488,15454,15041,15124],0); -ELEMENTS[66507] = Fluid3D([15454,15041,15124,15630],0); -ELEMENTS[66508] = Fluid3D([15488,15655,15454,15124],0); -ELEMENTS[66509] = Fluid3D([15655,15454,15124,15630],0); -ELEMENTS[66510] = Fluid3D([6301,6278,5778,5847],0); -ELEMENTS[66511] = Fluid3D([12929,13571,12610,13428],0); -ELEMENTS[66512] = Fluid3D([3149,3553,3330,3246],0); -ELEMENTS[66513] = Fluid3D([15963,15905,16070,16628],0); -ELEMENTS[66514] = Fluid3D([2532,2514,2272,2365],0); -ELEMENTS[66515] = Fluid3D([7935,7514,7221,8091],0); -ELEMENTS[66516] = Fluid3D([18468,18442,18428,18243],0); -ELEMENTS[66517] = Fluid3D([9919,10467,11077,10818],0); -ELEMENTS[66518] = Fluid3D([16193,16206,16717,16686],0); -ELEMENTS[66519] = Fluid3D([16193,16206,16686,16259],0); -ELEMENTS[66520] = Fluid3D([18639,18577,18600,18474],0); -ELEMENTS[66521] = Fluid3D([12984,12302,13271,13092],0); -ELEMENTS[66522] = Fluid3D([17600,17649,17451,17175],0); -ELEMENTS[66523] = Fluid3D([12827,13531,13931,13090],0); -ELEMENTS[66524] = Fluid3D([10651,11365,11537,10470],0); -ELEMENTS[66525] = Fluid3D([10651,11365,10470,9917],0); -ELEMENTS[66526] = Fluid3D([9239,8951,9020,9266],0); -ELEMENTS[66527] = Fluid3D([9398,9636,8615,8488],0); -ELEMENTS[66528] = Fluid3D([8615,9398,8488,8574],0); -ELEMENTS[66529] = Fluid3D([13906,13790,13836,13217],0); -ELEMENTS[66530] = Fluid3D([11774,12530,12554,11790],0); -ELEMENTS[66531] = Fluid3D([12554,11774,11790,11164],0); -ELEMENTS[66532] = Fluid3D([14513,14268,15084,14823],0); -ELEMENTS[66533] = Fluid3D([10029,10652,9602,9583],0); -ELEMENTS[66534] = Fluid3D([15611,16266,15807,15508],0); -ELEMENTS[66535] = Fluid3D([15807,15611,15508,14770],0); -ELEMENTS[66536] = Fluid3D([13573,14078,13269,14085],0); -ELEMENTS[66537] = Fluid3D([6585,7406,6430,7217],0); -ELEMENTS[66538] = Fluid3D([12111,12806,12058,11821],0); -ELEMENTS[66539] = Fluid3D([11236,10968,12020,12001],0); -ELEMENTS[66540] = Fluid3D([15867,15997,16382,16477],0); -ELEMENTS[66541] = Fluid3D([9160,10008,9932,9176],0); -ELEMENTS[66542] = Fluid3D([6219,6812,6878,6236],0); -ELEMENTS[66543] = Fluid3D([6219,6812,6236,5726],0); -ELEMENTS[66544] = Fluid3D([12898,12074,12107,12281],0); -ELEMENTS[66545] = Fluid3D([12898,12074,12281,12165],0); -ELEMENTS[66546] = Fluid3D([14355,14206,14678,15047],0); -ELEMENTS[66547] = Fluid3D([14206,14678,15047,14472],0); -ELEMENTS[66548] = Fluid3D([14206,14678,14472,13530],0); -ELEMENTS[66549] = Fluid3D([14472,14206,13530,14462],0); -ELEMENTS[66550] = Fluid3D([10773,11311,11755,11552],0); -ELEMENTS[66551] = Fluid3D([2019,1919,2116,1989],0); -ELEMENTS[66552] = Fluid3D([16881,16749,16356,16303],0); -ELEMENTS[66553] = Fluid3D([8816,9576,9463,10098],0); -ELEMENTS[66554] = Fluid3D([12634,11879,12247,12639],0); -ELEMENTS[66555] = Fluid3D([12247,12634,12639,13252],0); -ELEMENTS[66556] = Fluid3D([12634,12639,13252,12709],0); -ELEMENTS[66557] = Fluid3D([12247,12634,13252,13303],0); -ELEMENTS[66558] = Fluid3D([12634,12639,12709,11879],0); -ELEMENTS[66559] = Fluid3D([12709,12634,11879,13048],0); -ELEMENTS[66560] = Fluid3D([13252,12634,12709,13048],0); -ELEMENTS[66561] = Fluid3D([13252,12634,13048,13303],0); -ELEMENTS[66562] = Fluid3D([14012,13903,13366,13110],0); -ELEMENTS[66563] = Fluid3D([13903,13366,13110,13775],0); -ELEMENTS[66564] = Fluid3D([8530,8514,8033,8763],0); -ELEMENTS[66565] = Fluid3D([13966,14227,14045,14570],0); -ELEMENTS[66566] = Fluid3D([13966,14227,14570,14767],0); -ELEMENTS[66567] = Fluid3D([18024,17747,18098,17731],0); -ELEMENTS[66568] = Fluid3D([17460,17201,17522,17705],0); -ELEMENTS[66569] = Fluid3D([3906,4087,3669,3458],0); -ELEMENTS[66570] = Fluid3D([13757,13219,12808,12850],0); -ELEMENTS[66571] = Fluid3D([16252,16238,16240,16674],0); -ELEMENTS[66572] = Fluid3D([9945,10142,9848,11164],0); -ELEMENTS[66573] = Fluid3D([13433,14097,13101,13001],0); -ELEMENTS[66574] = Fluid3D([16018,16443,15911,15907],0); -ELEMENTS[66575] = Fluid3D([17619,17875,17731,17670],0); -ELEMENTS[66576] = Fluid3D([17731,17619,17670,17236],0); -ELEMENTS[66577] = Fluid3D([17619,17670,17236,17168],0); -ELEMENTS[66578] = Fluid3D([17619,17875,17670,18067],0); -ELEMENTS[66579] = Fluid3D([17619,17670,17168,17515],0); -ELEMENTS[66580] = Fluid3D([17670,17619,18067,17839],0); -ELEMENTS[66581] = Fluid3D([17670,17619,17839,17515],0); -ELEMENTS[66582] = Fluid3D([18210,18333,18238,18060],0); -ELEMENTS[66583] = Fluid3D([16281,16446,16457,16195],0); -ELEMENTS[66584] = Fluid3D([12385,12324,12664,13231],0); -ELEMENTS[66585] = Fluid3D([5317,4990,4983,4641],0); -ELEMENTS[66586] = Fluid3D([5645,5170,4837,5322],0); -ELEMENTS[66587] = Fluid3D([1961,1893,1785,1872],0); -ELEMENTS[66588] = Fluid3D([1961,1893,1872,1910],0); -ELEMENTS[66589] = Fluid3D([1893,1872,1910,1713],0); -ELEMENTS[66590] = Fluid3D([1872,1961,1910,2013],0); -ELEMENTS[66591] = Fluid3D([1910,1872,2013,1941],0); -ELEMENTS[66592] = Fluid3D([1872,2013,1941,2122],0); -ELEMENTS[66593] = Fluid3D([1872,2013,2122,1961],0); -ELEMENTS[66594] = Fluid3D([2013,1941,2122,2006],0); -ELEMENTS[66595] = Fluid3D([2122,2013,2006,2118],0); -ELEMENTS[66596] = Fluid3D([2122,2013,2118,2045],0); -ELEMENTS[66597] = Fluid3D([2122,2013,2045,1961],0); -ELEMENTS[66598] = Fluid3D([2013,2118,2045,1910],0); -ELEMENTS[66599] = Fluid3D([2045,2013,1910,1961],0); -ELEMENTS[66600] = Fluid3D([2013,2118,1910,2006],0); -ELEMENTS[66601] = Fluid3D([1910,2013,2006,1941],0); -ELEMENTS[66602] = Fluid3D([1910,1872,1941,1767],0); -ELEMENTS[66603] = Fluid3D([1910,1872,1767,1713],0); -ELEMENTS[66604] = Fluid3D([11996,11000,11104,10778],0); -ELEMENTS[66605] = Fluid3D([11171,10791,10157,9723],0); -ELEMENTS[66606] = Fluid3D([16869,16943,17368,17266],0); -ELEMENTS[66607] = Fluid3D([5276,5272,5513,4832],0); -ELEMENTS[66608] = Fluid3D([15376,14834,14439,14936],0); -ELEMENTS[66609] = Fluid3D([15376,14834,14936,15623],0); -ELEMENTS[66610] = Fluid3D([11861,11848,11233,12237],0); -ELEMENTS[66611] = Fluid3D([6187,5875,6618,5806],0); -ELEMENTS[66612] = Fluid3D([13291,13317,13547,12421],0); -ELEMENTS[66613] = Fluid3D([16429,16447,15831,16260],0); -ELEMENTS[66614] = Fluid3D([17965,18154,18279,18026],0); -ELEMENTS[66615] = Fluid3D([6564,7142,7042,6072],0); -ELEMENTS[66616] = Fluid3D([18244,18389,18360,18443],0); -ELEMENTS[66617] = Fluid3D([5377,4934,5585,5091],0); -ELEMENTS[66618] = Fluid3D([5377,4934,5091,4666],0); -ELEMENTS[66619] = Fluid3D([7315,6811,6763,6212],0); -ELEMENTS[66620] = Fluid3D([7861,8156,8105,8920],0); -ELEMENTS[66621] = Fluid3D([8818,9184,9226,9943],0); -ELEMENTS[66622] = Fluid3D([9226,8818,9943,8897],0); -ELEMENTS[66623] = Fluid3D([16363,16563,15943,16199],0); -ELEMENTS[66624] = Fluid3D([2871,2720,3164,2692],0); -ELEMENTS[66625] = Fluid3D([5709,5950,5378,5249],0); -ELEMENTS[66626] = Fluid3D([14996,14388,13818,13798],0); -ELEMENTS[66627] = Fluid3D([15914,15478,16029,16251],0); -ELEMENTS[66628] = Fluid3D([13629,13089,13250,13353],0); -ELEMENTS[66629] = Fluid3D([13250,13629,13353,14117],0); -ELEMENTS[66630] = Fluid3D([13629,13089,13353,12705],0); -ELEMENTS[66631] = Fluid3D([13353,13629,12705,13505],0); -ELEMENTS[66632] = Fluid3D([13629,13353,14117,14446],0); -ELEMENTS[66633] = Fluid3D([16298,16049,15804,16261],0); -ELEMENTS[66634] = Fluid3D([11432,11750,12465,11778],0); -ELEMENTS[66635] = Fluid3D([9499,10502,9753,10456],0); -ELEMENTS[66636] = Fluid3D([6912,6360,6233,5744],0); -ELEMENTS[66637] = Fluid3D([13539,14125,14343,13660],0); -ELEMENTS[66638] = Fluid3D([18229,18075,18318,18249],0); -ELEMENTS[66639] = Fluid3D([4376,4462,4751,4507],0); -ELEMENTS[66640] = Fluid3D([4376,4462,4507,3912],0); -ELEMENTS[66641] = Fluid3D([4376,4462,3912,3946],0); -ELEMENTS[66642] = Fluid3D([12588,12554,11790,11978],0); -ELEMENTS[66643] = Fluid3D([8906,8141,9233,8390],0); -ELEMENTS[66644] = Fluid3D([15852,15674,16056,15828],0); -ELEMENTS[66645] = Fluid3D([14691,14877,15386,15502],0); -ELEMENTS[66646] = Fluid3D([3861,3579,3479,3250],0); -ELEMENTS[66647] = Fluid3D([14194,14069,13947,13210],0); -ELEMENTS[66648] = Fluid3D([6971,6679,7622,6900],0); -ELEMENTS[66649] = Fluid3D([15354,15541,15545,16122],0); -ELEMENTS[66650] = Fluid3D([16126,16051,16258,16593],0); -ELEMENTS[66651] = Fluid3D([5685,5535,6314,6005],0); -ELEMENTS[66652] = Fluid3D([6314,5685,6005,6020],0); -ELEMENTS[66653] = Fluid3D([13953,14311,13917,14468],0); -ELEMENTS[66654] = Fluid3D([13953,14311,14468,14908],0); -ELEMENTS[66655] = Fluid3D([14311,14468,14908,13845],0); -ELEMENTS[66656] = Fluid3D([13953,14311,14908,14959],0); -ELEMENTS[66657] = Fluid3D([13953,14311,14959,14764],0); -ELEMENTS[66658] = Fluid3D([14311,14908,14959,14764],0); -ELEMENTS[66659] = Fluid3D([14311,14468,13845,13917],0); -ELEMENTS[66660] = Fluid3D([2292,2416,2483,2163],0); -ELEMENTS[66661] = Fluid3D([11918,12745,12027,12736],0); -ELEMENTS[66662] = Fluid3D([11918,12745,12736,12128],0); -ELEMENTS[66663] = Fluid3D([11770,12090,11160,12544],0); -ELEMENTS[66664] = Fluid3D([10382,10948,11051,11316],0); -ELEMENTS[66665] = Fluid3D([2350,2224,2132,2072],0); -ELEMENTS[66666] = Fluid3D([9619,10066,10317,11022],0); -ELEMENTS[66667] = Fluid3D([15475,15675,15316,16291],0); -ELEMENTS[66668] = Fluid3D([9056,9981,9411,9237],0); -ELEMENTS[66669] = Fluid3D([7363,7078,7626,8115],0); -ELEMENTS[66670] = Fluid3D([11455,10766,11255,11579],0); -ELEMENTS[66671] = Fluid3D([13311,12365,12985,12522],0); -ELEMENTS[66672] = Fluid3D([4556,5208,4646,5129],0); -ELEMENTS[66673] = Fluid3D([3144,3440,3036,3009],0); -ELEMENTS[66674] = Fluid3D([4117,4107,4620,3957],0); -ELEMENTS[66675] = Fluid3D([3990,4011,4105,3553],0); -ELEMENTS[66676] = Fluid3D([13849,13828,14612,13823],0); -ELEMENTS[66677] = Fluid3D([14477,13953,14157,14468],0); -ELEMENTS[66678] = Fluid3D([12581,12756,13699,13266],0); -ELEMENTS[66679] = Fluid3D([7587,8349,8453,8486],0); -ELEMENTS[66680] = Fluid3D([8349,8453,8486,9237],0); -ELEMENTS[66681] = Fluid3D([8453,8486,9237,8213],0); -ELEMENTS[66682] = Fluid3D([8486,9237,8213,8630],0); -ELEMENTS[66683] = Fluid3D([8213,8486,8630,8403],0); -ELEMENTS[66684] = Fluid3D([8486,8630,8403,9237],0); -ELEMENTS[66685] = Fluid3D([7587,8349,8486,8403],0); -ELEMENTS[66686] = Fluid3D([8349,8486,8403,9237],0); -ELEMENTS[66687] = Fluid3D([8213,8486,8403,7587],0); -ELEMENTS[66688] = Fluid3D([8213,8486,7587,8453],0); -ELEMENTS[66689] = Fluid3D([13323,13994,14160,14304],0); -ELEMENTS[66690] = Fluid3D([10118,9855,10932,9962],0); -ELEMENTS[66691] = Fluid3D([17666,17377,17252,17510],0); -ELEMENTS[66692] = Fluid3D([7555,6755,7041,6985],0); -ELEMENTS[66693] = Fluid3D([3553,3662,3330,3670],0); -ELEMENTS[66694] = Fluid3D([3662,3330,3670,3612],0); -ELEMENTS[66695] = Fluid3D([3670,3662,3612,4318],0); -ELEMENTS[66696] = Fluid3D([3662,3330,3612,3863],0); -ELEMENTS[66697] = Fluid3D([3612,3662,3863,4318],0); -ELEMENTS[66698] = Fluid3D([3553,3662,3670,4011],0); -ELEMENTS[66699] = Fluid3D([3662,3670,4011,4318],0); -ELEMENTS[66700] = Fluid3D([10956,10102,9983,10958],0); -ELEMENTS[66701] = Fluid3D([4883,4795,4343,4679],0); -ELEMENTS[66702] = Fluid3D([10855,11909,11171,11189],0); -ELEMENTS[66703] = Fluid3D([2300,2482,2257,2464],0); -ELEMENTS[66704] = Fluid3D([16977,16794,16883,16369],0); -ELEMENTS[66705] = Fluid3D([4541,4628,4663,4946],0); -ELEMENTS[66706] = Fluid3D([5397,5704,5149,5558],0); -ELEMENTS[66707] = Fluid3D([16433,15797,16202,16365],0); -ELEMENTS[66708] = Fluid3D([12178,12320,12182,11212],0); -ELEMENTS[66709] = Fluid3D([2365,2618,2673,2744],0); -ELEMENTS[66710] = Fluid3D([7242,8251,8140,7763],0); -ELEMENTS[66711] = Fluid3D([18031,17868,18075,17895],0); -ELEMENTS[66712] = Fluid3D([7028,7074,7263,7781],0); -ELEMENTS[66713] = Fluid3D([11392,11851,10561,11799],0); -ELEMENTS[66714] = Fluid3D([4364,4037,4097,4583],0); -ELEMENTS[66715] = Fluid3D([4097,4364,4583,4753],0); -ELEMENTS[66716] = Fluid3D([4364,4583,4753,4774],0); -ELEMENTS[66717] = Fluid3D([4364,4583,4774,4037],0); -ELEMENTS[66718] = Fluid3D([13443,13889,13377,13124],0); -ELEMENTS[66719] = Fluid3D([8056,8076,7803,8756],0); -ELEMENTS[66720] = Fluid3D([4206,4543,4326,3982],0); -ELEMENTS[66721] = Fluid3D([11814,12782,12570,12617],0); -ELEMENTS[66722] = Fluid3D([15277,15127,14851,15897],0); -ELEMENTS[66723] = Fluid3D([7283,6468,7312,6741],0); -ELEMENTS[66724] = Fluid3D([13319,13125,13166,13881],0); -ELEMENTS[66725] = Fluid3D([13319,13125,13881,13954],0); -ELEMENTS[66726] = Fluid3D([13125,13166,13881,13505],0); -ELEMENTS[66727] = Fluid3D([14921,14709,15181,15417],0); -ELEMENTS[66728] = Fluid3D([14921,14709,15417,15301],0); -ELEMENTS[66729] = Fluid3D([15417,14921,15301,15793],0); -ELEMENTS[66730] = Fluid3D([15181,14921,15417,15793],0); -ELEMENTS[66731] = Fluid3D([14921,14709,15301,14797],0); -ELEMENTS[66732] = Fluid3D([15301,14921,14797,14357],0); -ELEMENTS[66733] = Fluid3D([15301,14921,14357,15355],0); -ELEMENTS[66734] = Fluid3D([15301,14921,15355,15793],0); -ELEMENTS[66735] = Fluid3D([14921,14797,14357,14273],0); -ELEMENTS[66736] = Fluid3D([6007,6321,6449,7016],0); -ELEMENTS[66737] = Fluid3D([11275,11258,12464,11640],0); -ELEMENTS[66738] = Fluid3D([7745,7266,6950,6998],0); -ELEMENTS[66739] = Fluid3D([7015,7022,6746,7593],0); -ELEMENTS[66740] = Fluid3D([7015,7022,7593,7731],0); -ELEMENTS[66741] = Fluid3D([7015,7022,7731,7406],0); -ELEMENTS[66742] = Fluid3D([7731,7015,7406,6614],0); -ELEMENTS[66743] = Fluid3D([10998,11023,10319,10888],0); -ELEMENTS[66744] = Fluid3D([5002,4813,5108,5589],0); -ELEMENTS[66745] = Fluid3D([9932,9734,9241,9176],0); -ELEMENTS[66746] = Fluid3D([9241,9932,9176,9160],0); -ELEMENTS[66747] = Fluid3D([7347,6960,7967,7928],0); -ELEMENTS[66748] = Fluid3D([7967,7347,7928,8233],0); -ELEMENTS[66749] = Fluid3D([11859,11706,11930,10958],0); -ELEMENTS[66750] = Fluid3D([11235,11771,11158,10605],0); -ELEMENTS[66751] = Fluid3D([15908,15778,15120,15872],0); -ELEMENTS[66752] = Fluid3D([15908,15778,15872,16434],0); -ELEMENTS[66753] = Fluid3D([17658,17847,18066,17679],0); -ELEMENTS[66754] = Fluid3D([17658,17847,17679,17277],0); -ELEMENTS[66755] = Fluid3D([17610,17416,17754,17790],0); -ELEMENTS[66756] = Fluid3D([17416,17754,17790,17850],0); -ELEMENTS[66757] = Fluid3D([11825,11572,11363,11739],0); -ELEMENTS[66758] = Fluid3D([16552,16584,15970,16407],0); -ELEMENTS[66759] = Fluid3D([10057,10181,9697,8908],0); -ELEMENTS[66760] = Fluid3D([16818,17088,16752,17108],0); -ELEMENTS[66761] = Fluid3D([5544,5711,5369,4956],0); -ELEMENTS[66762] = Fluid3D([12087,12464,11275,11033],0); -ELEMENTS[66763] = Fluid3D([16906,17240,17077,16634],0); -ELEMENTS[66764] = Fluid3D([4028,3768,3652,4337],0); -ELEMENTS[66765] = Fluid3D([18148,18011,17876,18329],0); -ELEMENTS[66766] = Fluid3D([16966,16749,16389,16201],0); -ELEMENTS[66767] = Fluid3D([12200,13012,13290,13486],0); -ELEMENTS[66768] = Fluid3D([12224,12892,13554,13051],0); -ELEMENTS[66769] = Fluid3D([18327,18321,18471,18461],0); -ELEMENTS[66770] = Fluid3D([15548,15326,15772,16121],0); -ELEMENTS[66771] = Fluid3D([15160,15333,14770,14216],0); -ELEMENTS[66772] = Fluid3D([17876,17401,17624,17650],0); -ELEMENTS[66773] = Fluid3D([4154,3995,4622,4348],0); -ELEMENTS[66774] = Fluid3D([16373,15828,16324,16164],0); -ELEMENTS[66775] = Fluid3D([16772,17280,16675,17181],0); -ELEMENTS[66776] = Fluid3D([4281,4337,3682,4025],0); -ELEMENTS[66777] = Fluid3D([17255,17623,17354,17241],0); -ELEMENTS[66778] = Fluid3D([11094,11567,10472,11489],0); -ELEMENTS[66779] = Fluid3D([10472,11094,11489,11188],0); -ELEMENTS[66780] = Fluid3D([15184,15892,15682,15223],0); -ELEMENTS[66781] = Fluid3D([10742,10582,10451,12252],0); -ELEMENTS[66782] = Fluid3D([8726,9122,8258,9457],0); -ELEMENTS[66783] = Fluid3D([14631,15292,14947,14607],0); -ELEMENTS[66784] = Fluid3D([14947,14631,14607,13952],0); -ELEMENTS[66785] = Fluid3D([14607,14947,13952,14612],0); -ELEMENTS[66786] = Fluid3D([11619,11389,11684,12604],0); -ELEMENTS[66787] = Fluid3D([16323,15786,16580,16157],0); -ELEMENTS[66788] = Fluid3D([4302,4084,3787,3911],0); -ELEMENTS[66789] = Fluid3D([17267,16825,16897,17333],0); -ELEMENTS[66790] = Fluid3D([16172,16564,15865,16138],0); -ELEMENTS[66791] = Fluid3D([16172,16564,16138,16164],0); -ELEMENTS[66792] = Fluid3D([11094,12186,11489,11188],0); -ELEMENTS[66793] = Fluid3D([18453,18498,18532,18380],0); -ELEMENTS[66794] = Fluid3D([18498,18532,18380,18451],0); -ELEMENTS[66795] = Fluid3D([17521,17584,17272,16987],0); -ELEMENTS[66796] = Fluid3D([10870,10894,9971,9929],0); -ELEMENTS[66797] = Fluid3D([13546,13974,12996,13844],0); -ELEMENTS[66798] = Fluid3D([10205,10133,10924,9378],0); -ELEMENTS[66799] = Fluid3D([13371,13020,14028,13750],0); -ELEMENTS[66800] = Fluid3D([18008,18062,18067,17721],0); -ELEMENTS[66801] = Fluid3D([4140,4240,3741,3799],0); -ELEMENTS[66802] = Fluid3D([12960,12784,13844,13644],0); -ELEMENTS[66803] = Fluid3D([12048,11172,12280,11884],0); -ELEMENTS[66804] = Fluid3D([5539,5912,6244,6123],0); -ELEMENTS[66805] = Fluid3D([5539,5912,6123,6135],0); -ELEMENTS[66806] = Fluid3D([3971,3914,4047,3537],0); -ELEMENTS[66807] = Fluid3D([3971,3914,3537,3316],0); -ELEMENTS[66808] = Fluid3D([14589,14634,15207,15170],0); -ELEMENTS[66809] = Fluid3D([14258,13826,13406,13316],0); -ELEMENTS[66810] = Fluid3D([12723,12792,13579,13053],0); -ELEMENTS[66811] = Fluid3D([8610,7775,7952,8367],0); -ELEMENTS[66812] = Fluid3D([7065,7320,6789,6949],0); -ELEMENTS[66813] = Fluid3D([11979,12661,11716,12427],0); -ELEMENTS[66814] = Fluid3D([13038,13422,14128,13483],0); -ELEMENTS[66815] = Fluid3D([13422,14128,13483,13311],0); -ELEMENTS[66816] = Fluid3D([7524,7950,8471,7354],0); -ELEMENTS[66817] = Fluid3D([6721,7581,7155,6835],0); -ELEMENTS[66818] = Fluid3D([6721,7581,6835,7364],0); -ELEMENTS[66819] = Fluid3D([15964,16419,15904,16558],0); -ELEMENTS[66820] = Fluid3D([15964,16419,16558,16176],0); -ELEMENTS[66821] = Fluid3D([15964,16419,16176,16362],0); -ELEMENTS[66822] = Fluid3D([11418,10450,10990,11862],0); -ELEMENTS[66823] = Fluid3D([14815,14882,14094,14656],0); -ELEMENTS[66824] = Fluid3D([14094,14815,14656,14594],0); -ELEMENTS[66825] = Fluid3D([18003,18097,18232,18155],0); -ELEMENTS[66826] = Fluid3D([18232,18003,18155,17832],0); -ELEMENTS[66827] = Fluid3D([4838,4721,5409,5202],0); -ELEMENTS[66828] = Fluid3D([4633,4497,4737,5133],0); -ELEMENTS[66829] = Fluid3D([5804,6131,6111,5576],0); -ELEMENTS[66830] = Fluid3D([17938,17773,17575,17821],0); -ELEMENTS[66831] = Fluid3D([17938,17773,17821,18099],0); -ELEMENTS[66832] = Fluid3D([16280,16078,15541,16024],0); -ELEMENTS[66833] = Fluid3D([4410,4440,4890,4719],0); -ELEMENTS[66834] = Fluid3D([14847,14506,15425,15390],0); -ELEMENTS[66835] = Fluid3D([13726,13292,12722,13452],0); -ELEMENTS[66836] = Fluid3D([6334,6335,5658,5751],0); -ELEMENTS[66837] = Fluid3D([2301,2426,2451,2735],0); -ELEMENTS[66838] = Fluid3D([6669,6953,7472,7842],0); -ELEMENTS[66839] = Fluid3D([5953,5582,6174,5828],0); -ELEMENTS[66840] = Fluid3D([8709,9170,9054,10009],0); -ELEMENTS[66841] = Fluid3D([9170,9054,10009,9853],0); -ELEMENTS[66842] = Fluid3D([2342,2507,2516,2211],0); -ELEMENTS[66843] = Fluid3D([12149,11857,11347,12409],0); -ELEMENTS[66844] = Fluid3D([3730,4137,4269,3890],0); -ELEMENTS[66845] = Fluid3D([13579,14154,13153,13484],0); -ELEMENTS[66846] = Fluid3D([2501,2823,2547,2910],0); -ELEMENTS[66847] = Fluid3D([10056,10895,11277,10488],0); -ELEMENTS[66848] = Fluid3D([9961,9109,9126,9583],0); -ELEMENTS[66849] = Fluid3D([9173,8525,8921,9728],0); -ELEMENTS[66850] = Fluid3D([11346,11039,12191,11849],0); -ELEMENTS[66851] = Fluid3D([13915,14430,14487,14861],0); -ELEMENTS[66852] = Fluid3D([14487,13915,14861,14579],0); -ELEMENTS[66853] = Fluid3D([15809,16320,16143,16290],0); -ELEMENTS[66854] = Fluid3D([13149,12794,13321,12652],0); -ELEMENTS[66855] = Fluid3D([13174,12414,12297,12786],0); -ELEMENTS[66856] = Fluid3D([12414,12297,12786,12808],0); -ELEMENTS[66857] = Fluid3D([12297,12786,12808,13017],0); -ELEMENTS[66858] = Fluid3D([12297,12786,13017,13174],0); -ELEMENTS[66859] = Fluid3D([12786,12808,13017,13174],0); -ELEMENTS[66860] = Fluid3D([12786,12414,12808,13174],0); -ELEMENTS[66861] = Fluid3D([13017,12297,13174,12058],0); -ELEMENTS[66862] = Fluid3D([17006,17165,16649,16695],0); -ELEMENTS[66863] = Fluid3D([13819,13458,14235,12947],0); -ELEMENTS[66864] = Fluid3D([13819,13458,12947,12679],0); -ELEMENTS[66865] = Fluid3D([13458,12947,12679,12162],0); -ELEMENTS[66866] = Fluid3D([6351,6404,6768,7190],0); -ELEMENTS[66867] = Fluid3D([2666,2865,2474,2783],0); -ELEMENTS[66868] = Fluid3D([3122,3334,2986,3215],0); -ELEMENTS[66869] = Fluid3D([2986,3122,3215,2705],0); -ELEMENTS[66870] = Fluid3D([14715,15182,14061,14579],0); -ELEMENTS[66871] = Fluid3D([5771,5965,6615,5777],0); -ELEMENTS[66872] = Fluid3D([2563,2644,2537,2884],0); -ELEMENTS[66873] = Fluid3D([10066,9412,9642,8865],0); -ELEMENTS[66874] = Fluid3D([8194,7419,7376,7461],0); -ELEMENTS[66875] = Fluid3D([5474,6062,5347,5355],0); -ELEMENTS[66876] = Fluid3D([14748,15390,15295,14506],0); -ELEMENTS[66877] = Fluid3D([13458,12856,13843,13213],0); -ELEMENTS[66878] = Fluid3D([12856,13843,13213,12568],0); -ELEMENTS[66879] = Fluid3D([12575,12566,13417,13099],0); -ELEMENTS[66880] = Fluid3D([4683,5132,4801,4463],0); -ELEMENTS[66881] = Fluid3D([9038,9393,9230,8337],0); -ELEMENTS[66882] = Fluid3D([12220,12301,10977,11687],0); -ELEMENTS[66883] = Fluid3D([9942,10206,11082,10705],0); -ELEMENTS[66884] = Fluid3D([3739,3692,3808,4268],0); -ELEMENTS[66885] = Fluid3D([13722,12873,13533,13147],0); -ELEMENTS[66886] = Fluid3D([18056,17983,17890,18165],0); -ELEMENTS[66887] = Fluid3D([7147,7087,6711,6251],0); -ELEMENTS[66888] = Fluid3D([3150,2928,2687,3129],0); -ELEMENTS[66889] = Fluid3D([3150,2928,3129,3206],0); -ELEMENTS[66890] = Fluid3D([17383,16960,17352,17177],0); -ELEMENTS[66891] = Fluid3D([8432,9171,8261,8426],0); -ELEMENTS[66892] = Fluid3D([18121,17860,18190,17925],0); -ELEMENTS[66893] = Fluid3D([11278,11454,12405,11439],0); -ELEMENTS[66894] = Fluid3D([11278,11454,11439,10268],0); -ELEMENTS[66895] = Fluid3D([6809,6362,6174,5953],0); -ELEMENTS[66896] = Fluid3D([3820,3642,4339,3893],0); -ELEMENTS[66897] = Fluid3D([13892,14510,13825,14265],0); -ELEMENTS[66898] = Fluid3D([13675,13899,13877,14736],0); -ELEMENTS[66899] = Fluid3D([6493,5909,6457,6314],0); -ELEMENTS[66900] = Fluid3D([11204,11705,10640,10859],0); -ELEMENTS[66901] = Fluid3D([9854,10276,9593,9500],0); -ELEMENTS[66902] = Fluid3D([16547,16505,16985,17020],0); -ELEMENTS[66903] = Fluid3D([8247,8792,9387,8556],0); -ELEMENTS[66904] = Fluid3D([15374,15401,14530,15205],0); -ELEMENTS[66905] = Fluid3D([15374,15401,15205,15585],0); -ELEMENTS[66906] = Fluid3D([15205,15374,15585,14495],0); -ELEMENTS[66907] = Fluid3D([10304,10653,9920,9457],0); -ELEMENTS[66908] = Fluid3D([10653,9920,9457,10947],0); -ELEMENTS[66909] = Fluid3D([8956,8484,9547,9829],0); -ELEMENTS[66910] = Fluid3D([7372,7917,7647,7662],0); -ELEMENTS[66911] = Fluid3D([6602,6692,6462,5845],0); -ELEMENTS[66912] = Fluid3D([10768,11440,10672,11908],0); -ELEMENTS[66913] = Fluid3D([10768,11440,11908,11229],0); -ELEMENTS[66914] = Fluid3D([15009,15372,15646,15113],0); -ELEMENTS[66915] = Fluid3D([5304,4777,5046,5238],0); -ELEMENTS[66916] = Fluid3D([9757,9786,8675,9411],0); -ELEMENTS[66917] = Fluid3D([3787,3540,4084,4047],0); -ELEMENTS[66918] = Fluid3D([4222,4783,4460,4912],0); -ELEMENTS[66919] = Fluid3D([16482,16581,16088,16225],0); -ELEMENTS[66920] = Fluid3D([8720,7938,7823,8886],0); -ELEMENTS[66921] = Fluid3D([8720,7938,8886,8814],0); -ELEMENTS[66922] = Fluid3D([8886,8720,8814,9954],0); -ELEMENTS[66923] = Fluid3D([7823,8720,8886,8636],0); -ELEMENTS[66924] = Fluid3D([8720,8886,8636,10006],0); -ELEMENTS[66925] = Fluid3D([14968,15684,15494,15762],0); -ELEMENTS[66926] = Fluid3D([3401,3383,3010,2936],0); -ELEMENTS[66927] = Fluid3D([16389,16294,16426,16732],0); -ELEMENTS[66928] = Fluid3D([16294,16426,16732,16858],0); -ELEMENTS[66929] = Fluid3D([15856,15831,15842,15020],0); -ELEMENTS[66930] = Fluid3D([3339,3062,3234,2876],0); -ELEMENTS[66931] = Fluid3D([13647,14294,13221,14192],0); -ELEMENTS[66932] = Fluid3D([14294,13221,14192,13639],0); -ELEMENTS[66933] = Fluid3D([11019,12161,11744,11704],0); -ELEMENTS[66934] = Fluid3D([9119,9576,10191,9463],0); -ELEMENTS[66935] = Fluid3D([14669,14853,15406,14333],0); -ELEMENTS[66936] = Fluid3D([5745,6360,5744,6233],0); -ELEMENTS[66937] = Fluid3D([5602,5352,5187,5615],0); -ELEMENTS[66938] = Fluid3D([9967,10622,10561,9281],0); -ELEMENTS[66939] = Fluid3D([13710,13966,13984,13735],0); -ELEMENTS[66940] = Fluid3D([15362,14882,15780,15391],0); -ELEMENTS[66941] = Fluid3D([15780,15362,15391,15526],0); -ELEMENTS[66942] = Fluid3D([4798,4564,5303,5329],0); -ELEMENTS[66943] = Fluid3D([7360,6746,6987,7593],0); -ELEMENTS[66944] = Fluid3D([7360,6746,7593,7015],0); -ELEMENTS[66945] = Fluid3D([18625,18572,18645,18661],0); -ELEMENTS[66946] = Fluid3D([12571,13108,12708,13098],0); -ELEMENTS[66947] = Fluid3D([17387,16973,16805,17224],0); -ELEMENTS[66948] = Fluid3D([16470,16784,16639,17112],0); -ELEMENTS[66949] = Fluid3D([13149,13925,13321,13807],0); -ELEMENTS[66950] = Fluid3D([9438,8987,9574,10224],0); -ELEMENTS[66951] = Fluid3D([2941,3089,2845,3191],0); -ELEMENTS[66952] = Fluid3D([3089,2845,3191,3229],0); -ELEMENTS[66953] = Fluid3D([2941,3089,3191,3386],0); -ELEMENTS[66954] = Fluid3D([14177,14098,14941,13809],0); -ELEMENTS[66955] = Fluid3D([14055,14362,13399,13617],0); -ELEMENTS[66956] = Fluid3D([12237,13072,11922,12683],0); -ELEMENTS[66957] = Fluid3D([15074,15491,15589,14844],0); -ELEMENTS[66958] = Fluid3D([14443,14002,13441,13896],0); -ELEMENTS[66959] = Fluid3D([16567,16831,16423,16046],0); -ELEMENTS[66960] = Fluid3D([14057,13487,14072,14571],0); -ELEMENTS[66961] = Fluid3D([14538,15074,14217,14360],0); -ELEMENTS[66962] = Fluid3D([14538,15074,14360,14892],0); -ELEMENTS[66963] = Fluid3D([14217,14538,14360,13408],0); -ELEMENTS[66964] = Fluid3D([18018,17827,17795,17895],0); -ELEMENTS[66965] = Fluid3D([17325,17484,17599,17690],0); -ELEMENTS[66966] = Fluid3D([13886,13680,13914,13317],0); -ELEMENTS[66967] = Fluid3D([16740,16992,17023,17109],0); -ELEMENTS[66968] = Fluid3D([4820,5328,5448,5112],0); -ELEMENTS[66969] = Fluid3D([15788,15880,15304,14915],0); -ELEMENTS[66970] = Fluid3D([8749,9693,9485,8473],0); -ELEMENTS[66971] = Fluid3D([16307,16759,16593,16051],0); -ELEMENTS[66972] = Fluid3D([9131,8485,7909,7595],0); -ELEMENTS[66973] = Fluid3D([7832,8568,8299,7402],0); -ELEMENTS[66974] = Fluid3D([18566,18590,18501,18437],0); -ELEMENTS[66975] = Fluid3D([7749,8067,8743,8502],0); -ELEMENTS[66976] = Fluid3D([4881,4264,4684,4130],0); -ELEMENTS[66977] = Fluid3D([12719,12209,12075,11721],0); -ELEMENTS[66978] = Fluid3D([9074,9440,9051,8075],0); -ELEMENTS[66979] = Fluid3D([13337,14019,13272,13879],0); -ELEMENTS[66980] = Fluid3D([16927,16763,17142,17392],0); -ELEMENTS[66981] = Fluid3D([2367,2214,2257,2210],0); -ELEMENTS[66982] = Fluid3D([5908,5852,5417,5601],0); -ELEMENTS[66983] = Fluid3D([8049,8219,8852,8365],0); -ELEMENTS[66984] = Fluid3D([9685,9499,8820,9265],0); -ELEMENTS[66985] = Fluid3D([13415,13302,13596,12678],0); -ELEMENTS[66986] = Fluid3D([15468,15798,15252,15965],0); -ELEMENTS[66987] = Fluid3D([16753,17099,16580,16669],0); -ELEMENTS[66988] = Fluid3D([15095,14409,15031,15183],0); -ELEMENTS[66989] = Fluid3D([9849,10057,10325,9132],0); -ELEMENTS[66990] = Fluid3D([2253,2466,2480,2273],0); -ELEMENTS[66991] = Fluid3D([13159,12902,12113,12638],0); -ELEMENTS[66992] = Fluid3D([4150,3950,3562,3737],0); -ELEMENTS[66993] = Fluid3D([14185,14403,13484,14157],0); -ELEMENTS[66994] = Fluid3D([5773,6123,5881,6450],0); -ELEMENTS[66995] = Fluid3D([11699,11405,12093,11390],0); -ELEMENTS[66996] = Fluid3D([3584,3235,3459,3658],0); -ELEMENTS[66997] = Fluid3D([9688,10699,9809,9850],0); -ELEMENTS[66998] = Fluid3D([15059,15752,15132,15225],0); -ELEMENTS[66999] = Fluid3D([2963,3187,3222,3157],0); -ELEMENTS[67000] = Fluid3D([13674,13228,14421,13784],0); -ELEMENTS[67001] = Fluid3D([3324,3255,3693,3322],0); -ELEMENTS[67002] = Fluid3D([3255,3693,3322,3061],0); -ELEMENTS[67003] = Fluid3D([3322,3255,3061,2834],0); -ELEMENTS[67004] = Fluid3D([3324,3255,3322,3063],0); -ELEMENTS[67005] = Fluid3D([3255,3322,3063,2834],0); -ELEMENTS[67006] = Fluid3D([3324,3255,3063,2834],0); -ELEMENTS[67007] = Fluid3D([5882,5467,6102,5324],0); -ELEMENTS[67008] = Fluid3D([4905,4408,4385,4405],0); -ELEMENTS[67009] = Fluid3D([7378,6991,7274,7632],0); -ELEMENTS[67010] = Fluid3D([6305,6038,5522,5959],0); -ELEMENTS[67011] = Fluid3D([5159,4922,4940,4604],0); -ELEMENTS[67012] = Fluid3D([5159,4922,4604,4892],0); -ELEMENTS[67013] = Fluid3D([16609,16447,16260,15842],0); -ELEMENTS[67014] = Fluid3D([8548,7977,8967,8186],0); -ELEMENTS[67015] = Fluid3D([8545,8671,8189,7542],0); -ELEMENTS[67016] = Fluid3D([7803,8756,8483,8056],0); -ELEMENTS[67017] = Fluid3D([6131,6766,6052,6044],0); -ELEMENTS[67018] = Fluid3D([9776,9597,10470,9208],0); -ELEMENTS[67019] = Fluid3D([17473,17587,17540,17677],0); -ELEMENTS[67020] = Fluid3D([17540,17473,17677,17254],0); -ELEMENTS[67021] = Fluid3D([13619,13196,13626,14043],0); -ELEMENTS[67022] = Fluid3D([6937,7498,7156,6446],0); -ELEMENTS[67023] = Fluid3D([7243,6713,6796,6190],0); -ELEMENTS[67024] = Fluid3D([12372,12448,13403,12301],0); -ELEMENTS[67025] = Fluid3D([8784,8378,8494,7536],0); -ELEMENTS[67026] = Fluid3D([12585,12910,12389,13123],0); -ELEMENTS[67027] = Fluid3D([10899,11144,10091,11472],0); -ELEMENTS[67028] = Fluid3D([10454,10370,11098,10386],0); -ELEMENTS[67029] = Fluid3D([17738,17381,17749,17467],0); -ELEMENTS[67030] = Fluid3D([3590,3285,3844,3528],0); -ELEMENTS[67031] = Fluid3D([3590,3285,3528,3560],0); -ELEMENTS[67032] = Fluid3D([14579,14861,14738,13915],0); -ELEMENTS[67033] = Fluid3D([11673,12591,11958,11924],0); -ELEMENTS[67034] = Fluid3D([11707,11159,12427,10867],0); -ELEMENTS[67035] = Fluid3D([5681,5355,5784,6062],0); -ELEMENTS[67036] = Fluid3D([17972,18266,18080,17874],0); -ELEMENTS[67037] = Fluid3D([16269,16201,15716,15985],0); -ELEMENTS[67038] = Fluid3D([9607,9621,8634,9902],0); -ELEMENTS[67039] = Fluid3D([1846,1814,1868,1706],0); -ELEMENTS[67040] = Fluid3D([11640,11518,10825,11258],0); -ELEMENTS[67041] = Fluid3D([11640,11518,11258,12464],0); -ELEMENTS[67042] = Fluid3D([5910,5576,5340,5545],0); -ELEMENTS[67043] = Fluid3D([6144,6075,6489,6966],0); -ELEMENTS[67044] = Fluid3D([13817,13331,14079,14198],0); -ELEMENTS[67045] = Fluid3D([7974,7678,8386,7127],0); -ELEMENTS[67046] = Fluid3D([7974,7678,7127,7537],0); -ELEMENTS[67047] = Fluid3D([16373,15911,16164,16464],0); -ELEMENTS[67048] = Fluid3D([15918,15380,15566,15061],0); -ELEMENTS[67049] = Fluid3D([14226,14697,14685,14721],0); -ELEMENTS[67050] = Fluid3D([14226,14697,14721,15092],0); -ELEMENTS[67051] = Fluid3D([4806,4350,4965,4564],0); -ELEMENTS[67052] = Fluid3D([6277,6750,6496,6812],0); -ELEMENTS[67053] = Fluid3D([14426,14549,14507,13349],0); -ELEMENTS[67054] = Fluid3D([18458,18413,18268,18421],0); -ELEMENTS[67055] = Fluid3D([14877,14845,15677,15201],0); -ELEMENTS[67056] = Fluid3D([14877,14845,15201,14832],0); -ELEMENTS[67057] = Fluid3D([14845,15201,14832,15020],0); -ELEMENTS[67058] = Fluid3D([15201,14832,15020,15665],0); -ELEMENTS[67059] = Fluid3D([15201,14832,15665,15486],0); -ELEMENTS[67060] = Fluid3D([15665,15201,15486,15677],0); -ELEMENTS[67061] = Fluid3D([15201,14832,15486,14877],0); -ELEMENTS[67062] = Fluid3D([15020,15201,15665,15677],0); -ELEMENTS[67063] = Fluid3D([15486,15201,14877,15677],0); -ELEMENTS[67064] = Fluid3D([18298,18397,18446,18531],0); -ELEMENTS[67065] = Fluid3D([11407,11313,12366,11292],0); -ELEMENTS[67066] = Fluid3D([6707,6780,6472,5930],0); -ELEMENTS[67067] = Fluid3D([5195,4638,4832,4425],0); -ELEMENTS[67068] = Fluid3D([16850,17142,17125,16684],0); -ELEMENTS[67069] = Fluid3D([17125,16850,16684,16766],0); -ELEMENTS[67070] = Fluid3D([12747,13241,12243,12838],0); -ELEMENTS[67071] = Fluid3D([9279,8543,9247,8847],0); -ELEMENTS[67072] = Fluid3D([9069,9473,9313,10421],0); -ELEMENTS[67073] = Fluid3D([6230,5684,6172,5950],0); -ELEMENTS[67074] = Fluid3D([8876,8934,9892,9091],0); -ELEMENTS[67075] = Fluid3D([8934,9892,9091,9011],0); -ELEMENTS[67076] = Fluid3D([4681,5123,4875,4851],0); -ELEMENTS[67077] = Fluid3D([16780,16980,17164,17282],0); -ELEMENTS[67078] = Fluid3D([9437,9279,10074,9859],0); -ELEMENTS[67079] = Fluid3D([2853,2830,2852,2561],0); -ELEMENTS[67080] = Fluid3D([2853,2830,2561,2788],0); -ELEMENTS[67081] = Fluid3D([2830,2852,2561,2681],0); -ELEMENTS[67082] = Fluid3D([2830,2852,2681,3138],0); -ELEMENTS[67083] = Fluid3D([2561,2830,2681,2760],0); -ELEMENTS[67084] = Fluid3D([2830,2681,2760,3138],0); -ELEMENTS[67085] = Fluid3D([2561,2830,2760,2788],0); -ELEMENTS[67086] = Fluid3D([2830,2760,2788,3155],0); -ELEMENTS[67087] = Fluid3D([12886,11974,12359,12643],0); -ELEMENTS[67088] = Fluid3D([13121,12533,12507,13225],0); -ELEMENTS[67089] = Fluid3D([12533,12507,13225,12057],0); -ELEMENTS[67090] = Fluid3D([17934,17789,17961,18093],0); -ELEMENTS[67091] = Fluid3D([17934,17789,18093,18156],0); -ELEMENTS[67092] = Fluid3D([6313,6633,7027,7154],0); -ELEMENTS[67093] = Fluid3D([16602,17100,16718,17055],0); -ELEMENTS[67094] = Fluid3D([10725,11450,10830,11030],0); -ELEMENTS[67095] = Fluid3D([8184,7677,7772,7668],0); -ELEMENTS[67096] = Fluid3D([13697,14099,13197,13438],0); -ELEMENTS[67097] = Fluid3D([14099,13197,13438,14054],0); -ELEMENTS[67098] = Fluid3D([13658,12876,13633,14147],0); -ELEMENTS[67099] = Fluid3D([14356,14871,13687,14160],0); -ELEMENTS[67100] = Fluid3D([13687,14356,14160,14587],0); -ELEMENTS[67101] = Fluid3D([7413,7803,8342,8483],0); -ELEMENTS[67102] = Fluid3D([5355,5285,5784,5347],0); -ELEMENTS[67103] = Fluid3D([8368,8661,7904,7837],0); -ELEMENTS[67104] = Fluid3D([5704,5592,5555,6298],0); -ELEMENTS[67105] = Fluid3D([16472,16761,16473,16800],0); -ELEMENTS[67106] = Fluid3D([15297,14545,14754,15025],0); -ELEMENTS[67107] = Fluid3D([6926,7853,6979,7161],0); -ELEMENTS[67108] = Fluid3D([6979,6926,7161,6521],0); -ELEMENTS[67109] = Fluid3D([18274,18086,18063,18004],0); -ELEMENTS[67110] = Fluid3D([2368,2207,2425,2528],0); -ELEMENTS[67111] = Fluid3D([14742,15163,14779,14030],0); -ELEMENTS[67112] = Fluid3D([8999,9293,8585,8692],0); -ELEMENTS[67113] = Fluid3D([3667,3565,4097,4296],0); -ELEMENTS[67114] = Fluid3D([13741,13276,12658,12756],0); -ELEMENTS[67115] = Fluid3D([13741,13276,12756,13949],0); -ELEMENTS[67116] = Fluid3D([12007,12144,11488,12721],0); -ELEMENTS[67117] = Fluid3D([11163,11537,12153,11839],0); -ELEMENTS[67118] = Fluid3D([6066,6263,6957,6460],0); -ELEMENTS[67119] = Fluid3D([2936,2889,2642,2659],0); -ELEMENTS[67120] = Fluid3D([4501,4899,4385,5005],0); -ELEMENTS[67121] = Fluid3D([4501,4899,5005,4464],0); -ELEMENTS[67122] = Fluid3D([17484,17717,17572,17915],0); -ELEMENTS[67123] = Fluid3D([14515,14816,14358,14946],0); -ELEMENTS[67124] = Fluid3D([5410,5200,4583,4857],0); -ELEMENTS[67125] = Fluid3D([5410,5200,4857,5283],0); -ELEMENTS[67126] = Fluid3D([11133,10898,10110,11442],0); -ELEMENTS[67127] = Fluid3D([13598,13454,13688,14409],0); -ELEMENTS[67128] = Fluid3D([13454,13688,14409,13912],0); -ELEMENTS[67129] = Fluid3D([10572,9662,10430,9133],0); -ELEMENTS[67130] = Fluid3D([6933,6751,7062,7972],0); -ELEMENTS[67131] = Fluid3D([12091,12239,11554,11232],0); -ELEMENTS[67132] = Fluid3D([11554,12091,11232,11549],0); -ELEMENTS[67133] = Fluid3D([12091,11232,11549,12330],0); -ELEMENTS[67134] = Fluid3D([12091,11232,12330,12239],0); -ELEMENTS[67135] = Fluid3D([11232,11549,12330,11962],0); -ELEMENTS[67136] = Fluid3D([7010,6298,6527,6797],0); -ELEMENTS[67137] = Fluid3D([14886,14976,14143,14031],0); -ELEMENTS[67138] = Fluid3D([5239,5897,5765,5093],0); -ELEMENTS[67139] = Fluid3D([10927,11449,11827,12221],0); -ELEMENTS[67140] = Fluid3D([11631,12469,11726,12894],0); -ELEMENTS[67141] = Fluid3D([13256,13850,13734,12884],0); -ELEMENTS[67142] = Fluid3D([17255,16871,17216,16954],0); -ELEMENTS[67143] = Fluid3D([10076,9593,10495,10640],0); -ELEMENTS[67144] = Fluid3D([9593,10495,10640,10012],0); -ELEMENTS[67145] = Fluid3D([9593,10495,10012,9983],0); -ELEMENTS[67146] = Fluid3D([10495,10012,9983,10956],0); -ELEMENTS[67147] = Fluid3D([10495,10012,10956,10640],0); -ELEMENTS[67148] = Fluid3D([16705,16288,15986,16704],0); -ELEMENTS[67149] = Fluid3D([14003,14403,14837,13964],0); -ELEMENTS[67150] = Fluid3D([17938,17575,17856,17889],0); -ELEMENTS[67151] = Fluid3D([5073,4965,5543,4814],0); -ELEMENTS[67152] = Fluid3D([6254,5975,6099,7104],0); -ELEMENTS[67153] = Fluid3D([11158,10987,11754,12266],0); -ELEMENTS[67154] = Fluid3D([12238,12376,11293,11904],0); -ELEMENTS[67155] = Fluid3D([1913,2087,2080,1931],0); -ELEMENTS[67156] = Fluid3D([6137,6083,5611,6224],0); -ELEMENTS[67157] = Fluid3D([2936,2925,3204,2973],0); -ELEMENTS[67158] = Fluid3D([4923,4841,5345,5206],0); -ELEMENTS[67159] = Fluid3D([4841,5345,5206,4580],0); -ELEMENTS[67160] = Fluid3D([4841,5345,4580,4746],0); -ELEMENTS[67161] = Fluid3D([15355,14694,15408,15500],0); -ELEMENTS[67162] = Fluid3D([15915,15603,16296,16277],0); -ELEMENTS[67163] = Fluid3D([3661,4104,4295,4202],0); -ELEMENTS[67164] = Fluid3D([10771,10443,11305,10458],0); -ELEMENTS[67165] = Fluid3D([18278,18314,18415,18186],0); -ELEMENTS[67166] = Fluid3D([10006,10439,9612,9954],0); -ELEMENTS[67167] = Fluid3D([7059,6771,6214,6084],0); -ELEMENTS[67168] = Fluid3D([8184,8139,9141,8642],0); -ELEMENTS[67169] = Fluid3D([8551,8203,8525,7673],0); -ELEMENTS[67170] = Fluid3D([8203,8525,7673,8145],0); -ELEMENTS[67171] = Fluid3D([8551,8203,7673,7237],0); -ELEMENTS[67172] = Fluid3D([3846,4367,4026,4000],0); -ELEMENTS[67173] = Fluid3D([4031,4462,3946,4404],0); -ELEMENTS[67174] = Fluid3D([12020,11386,12524,12675],0); -ELEMENTS[67175] = Fluid3D([15542,14900,15290,15433],0); -ELEMENTS[67176] = Fluid3D([8837,8305,9213,9556],0); -ELEMENTS[67177] = Fluid3D([17299,16862,17182,17040],0); -ELEMENTS[67178] = Fluid3D([4262,4098,3871,3843],0); -ELEMENTS[67179] = Fluid3D([9004,9139,8230,8995],0); -ELEMENTS[67180] = Fluid3D([13707,13354,13334,14410],0); -ELEMENTS[67181] = Fluid3D([13257,14131,13563,13011],0); -ELEMENTS[67182] = Fluid3D([13563,13257,13011,12721],0); -ELEMENTS[67183] = Fluid3D([13257,14131,13011,13608],0); -ELEMENTS[67184] = Fluid3D([13011,13257,13608,12637],0); -ELEMENTS[67185] = Fluid3D([13257,13011,12721,12144],0); -ELEMENTS[67186] = Fluid3D([13257,13011,12144,12637],0); -ELEMENTS[67187] = Fluid3D([13257,14131,13608,13634],0); -ELEMENTS[67188] = Fluid3D([8353,7589,8202,8035],0); -ELEMENTS[67189] = Fluid3D([8353,7589,8035,7189],0); -ELEMENTS[67190] = Fluid3D([2367,2482,2602,2257],0); -ELEMENTS[67191] = Fluid3D([5965,5524,5530,5311],0); -ELEMENTS[67192] = Fluid3D([12251,12386,12202,13126],0); -ELEMENTS[67193] = Fluid3D([13485,12496,13494,13161],0); -ELEMENTS[67194] = Fluid3D([13494,13485,13161,13720],0); -ELEMENTS[67195] = Fluid3D([11989,12913,12023,12493],0); -ELEMENTS[67196] = Fluid3D([6655,7036,6572,7396],0); -ELEMENTS[67197] = Fluid3D([6588,6406,7253,6180],0); -ELEMENTS[67198] = Fluid3D([5535,5883,6314,6397],0); -ELEMENTS[67199] = Fluid3D([11689,11405,12207,12629],0); -ELEMENTS[67200] = Fluid3D([1832,1960,1816,1861],0); -ELEMENTS[67201] = Fluid3D([2234,2269,2147,2051],0); -ELEMENTS[67202] = Fluid3D([2147,2234,2051,1955],0); -ELEMENTS[67203] = Fluid3D([2051,2147,1955,2018],0); -ELEMENTS[67204] = Fluid3D([1955,2051,2018,1972],0); -ELEMENTS[67205] = Fluid3D([1955,2051,1972,2234],0); -ELEMENTS[67206] = Fluid3D([2051,1972,2234,2135],0); -ELEMENTS[67207] = Fluid3D([2051,1972,2135,2081],0); -ELEMENTS[67208] = Fluid3D([2051,1972,2081,2018],0); -ELEMENTS[67209] = Fluid3D([2081,2051,2018,2269],0); -ELEMENTS[67210] = Fluid3D([2081,2051,2269,2135],0); -ELEMENTS[67211] = Fluid3D([2234,2269,2051,2135],0); -ELEMENTS[67212] = Fluid3D([2147,1955,2018,1933],0); -ELEMENTS[67213] = Fluid3D([2051,2147,2018,2269],0); -ELEMENTS[67214] = Fluid3D([2147,1955,1933,2179],0); -ELEMENTS[67215] = Fluid3D([2147,1955,2179,2234],0); -ELEMENTS[67216] = Fluid3D([2179,2147,2234,2381],0); -ELEMENTS[67217] = Fluid3D([15417,15745,15181,15793],0); -ELEMENTS[67218] = Fluid3D([16132,16043,15798,16586],0); -ELEMENTS[67219] = Fluid3D([9322,9498,9073,9788],0); -ELEMENTS[67220] = Fluid3D([13115,12445,12598,12107],0); -ELEMENTS[67221] = Fluid3D([2550,2310,2193,2350],0); -ELEMENTS[67222] = Fluid3D([2550,2310,2350,2207],0); -ELEMENTS[67223] = Fluid3D([6586,5976,7026,6399],0); -ELEMENTS[67224] = Fluid3D([15345,15250,15730,15774],0); -ELEMENTS[67225] = Fluid3D([17511,17457,17797,17698],0); -ELEMENTS[67226] = Fluid3D([3672,3215,3415,3334],0); -ELEMENTS[67227] = Fluid3D([17327,17005,17279,17526],0); -ELEMENTS[67228] = Fluid3D([17005,17279,17526,17009],0); -ELEMENTS[67229] = Fluid3D([5797,5559,6161,5453],0); -ELEMENTS[67230] = Fluid3D([12550,12234,11220,12037],0); -ELEMENTS[67231] = Fluid3D([12234,11220,12037,11621],0); -ELEMENTS[67232] = Fluid3D([4468,3992,4448,4425],0); -ELEMENTS[67233] = Fluid3D([5269,5348,4691,5155],0); -ELEMENTS[67234] = Fluid3D([5269,5348,5155,5602],0); -ELEMENTS[67235] = Fluid3D([5155,5269,5602,4791],0); -ELEMENTS[67236] = Fluid3D([9911,9316,10432,10372],0); -ELEMENTS[67237] = Fluid3D([2960,3210,3314,2736],0); -ELEMENTS[67238] = Fluid3D([12331,13138,12967,13649],0); -ELEMENTS[67239] = Fluid3D([3397,3767,3848,4029],0); -ELEMENTS[67240] = Fluid3D([15419,15891,16265,15755],0); -ELEMENTS[67241] = Fluid3D([15419,15891,15755,16027],0); -ELEMENTS[67242] = Fluid3D([5103,4874,5078,5364],0); -ELEMENTS[67243] = Fluid3D([16517,16018,15888,16540],0); -ELEMENTS[67244] = Fluid3D([16104,15765,16553,16265],0); -ELEMENTS[67245] = Fluid3D([17130,17238,16963,16777],0); -ELEMENTS[67246] = Fluid3D([17130,17238,16777,16965],0); -ELEMENTS[67247] = Fluid3D([5684,5261,5330,5626],0); -ELEMENTS[67248] = Fluid3D([5261,5330,5626,5093],0); -ELEMENTS[67249] = Fluid3D([5330,5626,5093,5765],0); -ELEMENTS[67250] = Fluid3D([5330,5626,5765,5684],0); -ELEMENTS[67251] = Fluid3D([5765,5330,5684,5249],0); -ELEMENTS[67252] = Fluid3D([5093,5330,5765,5168],0); -ELEMENTS[67253] = Fluid3D([5330,5765,5168,5249],0); -ELEMENTS[67254] = Fluid3D([5093,5330,5168,4516],0); -ELEMENTS[67255] = Fluid3D([17113,17239,16839,16924],0); -ELEMENTS[67256] = Fluid3D([17113,17239,16924,17443],0); -ELEMENTS[67257] = Fluid3D([12643,12359,11546,11974],0); -ELEMENTS[67258] = Fluid3D([10707,9995,10557,10786],0); -ELEMENTS[67259] = Fluid3D([10557,10707,10786,11506],0); -ELEMENTS[67260] = Fluid3D([10786,10557,11506,11969],0); -ELEMENTS[67261] = Fluid3D([9995,10557,10786,9420],0); -ELEMENTS[67262] = Fluid3D([10707,9995,10786,11506],0); -ELEMENTS[67263] = Fluid3D([10062,9025,9521,8987],0); -ELEMENTS[67264] = Fluid3D([2438,2258,2353,2294],0); -ELEMENTS[67265] = Fluid3D([2800,2653,2739,3116],0); -ELEMENTS[67266] = Fluid3D([15413,15360,15931,15306],0); -ELEMENTS[67267] = Fluid3D([17828,17942,17542,17729],0); -ELEMENTS[67268] = Fluid3D([17542,17828,17729,17633],0); -ELEMENTS[67269] = Fluid3D([17542,17828,17633,17648],0); -ELEMENTS[67270] = Fluid3D([8190,8353,8649,7880],0); -ELEMENTS[67271] = Fluid3D([3329,3285,3528,3844],0); -ELEMENTS[67272] = Fluid3D([9085,9800,9471,9495],0); -ELEMENTS[67273] = Fluid3D([3557,3714,3980,3881],0); -ELEMENTS[67274] = Fluid3D([7732,8331,7716,6902],0); -ELEMENTS[67275] = Fluid3D([5937,5977,6255,5529],0); -ELEMENTS[67276] = Fluid3D([5937,5977,5529,5282],0); -ELEMENTS[67277] = Fluid3D([6062,5806,5347,6187],0); -ELEMENTS[67278] = Fluid3D([5057,5379,5799,5334],0); -ELEMENTS[67279] = Fluid3D([14050,13186,13709,14476],0); -ELEMENTS[67280] = Fluid3D([13709,14050,14476,13986],0); -ELEMENTS[67281] = Fluid3D([14050,13186,14476,13699],0); -ELEMENTS[67282] = Fluid3D([9487,10305,9504,9762],0); -ELEMENTS[67283] = Fluid3D([9103,9495,10307,9800],0); -ELEMENTS[67284] = Fluid3D([12462,13190,12550,12037],0); -ELEMENTS[67285] = Fluid3D([11288,10451,10628,12252],0); -ELEMENTS[67286] = Fluid3D([16050,16310,15917,15445],0); -ELEMENTS[67287] = Fluid3D([3336,3577,3522,3505],0); -ELEMENTS[67288] = Fluid3D([5932,5329,5543,5562],0); -ELEMENTS[67289] = Fluid3D([13459,12911,13956,13532],0); -ELEMENTS[67290] = Fluid3D([13219,12934,12808,12246],0); -ELEMENTS[67291] = Fluid3D([12808,13219,12246,12850],0); -ELEMENTS[67292] = Fluid3D([15361,15777,15296,14941],0); -ELEMENTS[67293] = Fluid3D([12048,12058,11184,12297],0); -ELEMENTS[67294] = Fluid3D([12048,12058,12297,13017],0); -ELEMENTS[67295] = Fluid3D([14272,13494,13928,13382],0); -ELEMENTS[67296] = Fluid3D([3659,3995,3961,3966],0); -ELEMENTS[67297] = Fluid3D([5666,6113,6341,6156],0); -ELEMENTS[67298] = Fluid3D([4367,4139,4000,4067],0); -ELEMENTS[67299] = Fluid3D([4952,4844,5402,4918],0); -ELEMENTS[67300] = Fluid3D([4844,5402,4918,5002],0); -ELEMENTS[67301] = Fluid3D([5402,4918,5002,5743],0); -ELEMENTS[67302] = Fluid3D([5402,4918,5743,5091],0); -ELEMENTS[67303] = Fluid3D([15162,15067,15344,15784],0); -ELEMENTS[67304] = Fluid3D([17329,17165,16864,17475],0); -ELEMENTS[67305] = Fluid3D([5549,6119,6268,5807],0); -ELEMENTS[67306] = Fluid3D([16298,16621,16261,16494],0); -ELEMENTS[67307] = Fluid3D([10739,11214,11693,10970],0); -ELEMENTS[67308] = Fluid3D([5461,5115,4800,4669],0); -ELEMENTS[67309] = Fluid3D([5498,5292,4805,4940],0); -ELEMENTS[67310] = Fluid3D([4934,4962,4427,4666],0); -ELEMENTS[67311] = Fluid3D([6629,6817,6161,6976],0); -ELEMENTS[67312] = Fluid3D([4272,4220,4793,4693],0); -ELEMENTS[67313] = Fluid3D([3913,3448,3949,3497],0); -ELEMENTS[67314] = Fluid3D([10281,10930,9950,9570],0); -ELEMENTS[67315] = Fluid3D([18237,18344,18448,18352],0); -ELEMENTS[67316] = Fluid3D([7783,8669,7690,8043],0); -ELEMENTS[67317] = Fluid3D([16063,15522,16204,15562],0); -ELEMENTS[67318] = Fluid3D([14648,14902,15137,15442],0); -ELEMENTS[67319] = Fluid3D([14902,15137,15442,15814],0); -ELEMENTS[67320] = Fluid3D([15334,15111,15764,15967],0); -ELEMENTS[67321] = Fluid3D([4795,4343,4679,4797],0); -ELEMENTS[67322] = Fluid3D([9265,9468,9959,10002],0); -ELEMENTS[67323] = Fluid3D([9468,9959,10002,10594],0); -ELEMENTS[67324] = Fluid3D([2697,2930,2504,2792],0); -ELEMENTS[67325] = Fluid3D([5880,5659,6068,5556],0); -ELEMENTS[67326] = Fluid3D([5659,6068,5556,5077],0); -ELEMENTS[67327] = Fluid3D([5556,5659,5077,5880],0); -ELEMENTS[67328] = Fluid3D([12705,12101,12847,13089],0); -ELEMENTS[67329] = Fluid3D([14806,14699,14444,14330],0); -ELEMENTS[67330] = Fluid3D([9412,9642,8865,8706],0); -ELEMENTS[67331] = Fluid3D([17754,17610,17790,17968],0); -ELEMENTS[67332] = Fluid3D([16117,15741,15314,15748],0); -ELEMENTS[67333] = Fluid3D([16117,15741,15748,15554],0); -ELEMENTS[67334] = Fluid3D([15441,15183,15711,16114],0); -ELEMENTS[67335] = Fluid3D([6533,6908,7410,7185],0); -ELEMENTS[67336] = Fluid3D([7348,6540,7566,7213],0); -ELEMENTS[67337] = Fluid3D([17477,17160,16958,17179],0); -ELEMENTS[67338] = Fluid3D([17639,17817,17480,17609],0); -ELEMENTS[67339] = Fluid3D([9247,10068,9279,9637],0); -ELEMENTS[67340] = Fluid3D([2092,2289,2186,2037],0); -ELEMENTS[67341] = Fluid3D([18318,18229,18249,18449],0); -ELEMENTS[67342] = Fluid3D([18290,18185,18439,18353],0); -ELEMENTS[67343] = Fluid3D([7981,7960,7259,7984],0); -ELEMENTS[67344] = Fluid3D([7981,7960,7984,8736],0); -ELEMENTS[67345] = Fluid3D([7984,7981,8736,8874],0); -ELEMENTS[67346] = Fluid3D([7259,7981,7984,6772],0); -ELEMENTS[67347] = Fluid3D([18350,18374,18469,18562],0); -ELEMENTS[67348] = Fluid3D([15793,15966,15355,15301],0); -ELEMENTS[67349] = Fluid3D([15793,15966,15301,15417],0); -ELEMENTS[67350] = Fluid3D([7283,6900,6968,8084],0); -ELEMENTS[67351] = Fluid3D([11705,11760,11801,10859],0); -ELEMENTS[67352] = Fluid3D([15343,15396,15632,14707],0); -ELEMENTS[67353] = Fluid3D([3417,3016,3066,3214],0); -ELEMENTS[67354] = Fluid3D([4893,4745,4281,4280],0); -ELEMENTS[67355] = Fluid3D([17200,17129,16687,16606],0); -ELEMENTS[67356] = Fluid3D([18627,18665,18638,18586],0); -ELEMENTS[67357] = Fluid3D([11135,11790,11164,11978],0); -ELEMENTS[67358] = Fluid3D([16280,16122,16445,15977],0); -ELEMENTS[67359] = Fluid3D([17479,17153,17327,17182],0); -ELEMENTS[67360] = Fluid3D([17327,17479,17182,17398],0); -ELEMENTS[67361] = Fluid3D([17479,17182,17398,17316],0); -ELEMENTS[67362] = Fluid3D([17479,17153,17182,17299],0); -ELEMENTS[67363] = Fluid3D([17327,17479,17398,17736],0); -ELEMENTS[67364] = Fluid3D([17182,17479,17299,17579],0); -ELEMENTS[67365] = Fluid3D([17182,17327,17398,16922],0); -ELEMENTS[67366] = Fluid3D([17182,17479,17579,17316],0); -ELEMENTS[67367] = Fluid3D([17153,17327,17182,16689],0); -ELEMENTS[67368] = Fluid3D([12231,12665,12167,11391],0); -ELEMENTS[67369] = Fluid3D([11608,11500,10688,10252],0); -ELEMENTS[67370] = Fluid3D([17097,17099,17228,16669],0); -ELEMENTS[67371] = Fluid3D([9226,8818,8897,8208],0); -ELEMENTS[67372] = Fluid3D([12527,12871,11901,11641],0); -ELEMENTS[67373] = Fluid3D([12527,12871,11641,12478],0); -ELEMENTS[67374] = Fluid3D([17744,17745,17340,17370],0); -ELEMENTS[67375] = Fluid3D([7966,8638,7425,8046],0); -ELEMENTS[67376] = Fluid3D([13642,13400,14057,14647],0); -ELEMENTS[67377] = Fluid3D([10308,10838,11492,11358],0); -ELEMENTS[67378] = Fluid3D([12185,11604,12711,11567],0); -ELEMENTS[67379] = Fluid3D([5274,5791,5976,5400],0); -ELEMENTS[67380] = Fluid3D([5274,5791,5400,5252],0); -ELEMENTS[67381] = Fluid3D([18188,18049,18163,18273],0); -ELEMENTS[67382] = Fluid3D([13749,14194,13244,12958],0); -ELEMENTS[67383] = Fluid3D([10386,11098,10782,10370],0); -ELEMENTS[67384] = Fluid3D([3176,2828,3036,2701],0); -ELEMENTS[67385] = Fluid3D([10704,10080,9725,10815],0); -ELEMENTS[67386] = Fluid3D([18048,18237,18312,18352],0); -ELEMENTS[67387] = Fluid3D([17320,17155,16750,17163],0); -ELEMENTS[67388] = Fluid3D([17320,17155,17163,17431],0); -ELEMENTS[67389] = Fluid3D([11050,12433,11676,11556],0); -ELEMENTS[67390] = Fluid3D([11664,10570,10962,11523],0); -ELEMENTS[67391] = Fluid3D([14334,14336,13844,13921],0); -ELEMENTS[67392] = Fluid3D([14334,14336,13921,14216],0); -ELEMENTS[67393] = Fluid3D([5953,5929,6419,6362],0); -ELEMENTS[67394] = Fluid3D([14711,15449,15105,14808],0); -ELEMENTS[67395] = Fluid3D([12256,11566,12127,12582],0); -ELEMENTS[67396] = Fluid3D([14870,14369,14895,14387],0); -ELEMENTS[67397] = Fluid3D([11448,10399,9956,11105],0); -ELEMENTS[67398] = Fluid3D([14022,13817,13000,13587],0); -ELEMENTS[67399] = Fluid3D([4390,4691,4506,5059],0); -ELEMENTS[67400] = Fluid3D([18686,18669,18675,18695],0); -ELEMENTS[67401] = Fluid3D([8049,8194,7376,8165],0); -ELEMENTS[67402] = Fluid3D([15227,14928,14429,14419],0); -ELEMENTS[67403] = Fluid3D([3777,4030,3569,3418],0); -ELEMENTS[67404] = Fluid3D([11722,11524,11566,12127],0); -ELEMENTS[67405] = Fluid3D([11722,11524,12127,12582],0); -ELEMENTS[67406] = Fluid3D([11451,12097,11594,11300],0); -ELEMENTS[67407] = Fluid3D([3681,4072,4296,4109],0); -ELEMENTS[67408] = Fluid3D([16993,17158,16627,16601],0); -ELEMENTS[67409] = Fluid3D([7856,7181,7745,8507],0); -ELEMENTS[67410] = Fluid3D([3393,3012,3356,3460],0); -ELEMENTS[67411] = Fluid3D([12531,11983,11891,12672],0); -ELEMENTS[67412] = Fluid3D([6064,5772,5605,5775],0); -ELEMENTS[67413] = Fluid3D([6838,7545,7378,8228],0); -ELEMENTS[67414] = Fluid3D([3492,3197,3244,2911],0); -ELEMENTS[67415] = Fluid3D([3244,3492,2911,3117],0); -ELEMENTS[67416] = Fluid3D([2665,2481,2469,2245],0); -ELEMENTS[67417] = Fluid3D([6797,6523,6163,6855],0); -ELEMENTS[67418] = Fluid3D([13646,14307,13865,13292],0); -ELEMENTS[67419] = Fluid3D([4452,3957,4193,4840],0); -ELEMENTS[67420] = Fluid3D([15130,15527,15002,15018],0); -ELEMENTS[67421] = Fluid3D([9240,9215,9610,8432],0); -ELEMENTS[67422] = Fluid3D([14072,14115,14793,14229],0); -ELEMENTS[67423] = Fluid3D([14115,14793,14229,15073],0); -ELEMENTS[67424] = Fluid3D([16871,16491,16757,16954],0); -ELEMENTS[67425] = Fluid3D([6047,5436,5842,5451],0); -ELEMENTS[67426] = Fluid3D([15528,15572,15315,16020],0); -ELEMENTS[67427] = Fluid3D([15724,16117,15314,15748],0); -ELEMENTS[67428] = Fluid3D([15724,16117,15748,16121],0); -ELEMENTS[67429] = Fluid3D([16117,15748,16121,16516],0); -ELEMENTS[67430] = Fluid3D([15314,15724,15748,15319],0); -ELEMENTS[67431] = Fluid3D([15724,15748,15319,16121],0); -ELEMENTS[67432] = Fluid3D([15314,15724,15319,14881],0); -ELEMENTS[67433] = Fluid3D([9424,9384,10369,10005],0); -ELEMENTS[67434] = Fluid3D([7583,8079,8573,8509],0); -ELEMENTS[67435] = Fluid3D([16672,16202,16945,16433],0); -ELEMENTS[67436] = Fluid3D([5814,5976,6399,7026],0); -ELEMENTS[67437] = Fluid3D([16005,15537,16195,15736],0); -ELEMENTS[67438] = Fluid3D([2813,2682,2888,3214],0); -ELEMENTS[67439] = Fluid3D([18528,18444,18493,18487],0); -ELEMENTS[67440] = Fluid3D([18493,18528,18487,18588],0); -ELEMENTS[67441] = Fluid3D([9708,9203,10359,9901],0); -ELEMENTS[67442] = Fluid3D([10789,10116,10673,9529],0); -ELEMENTS[67443] = Fluid3D([15988,16193,15730,15346],0); -ELEMENTS[67444] = Fluid3D([18466,18257,18342,18321],0); -ELEMENTS[67445] = Fluid3D([4039,3807,3590,3829],0); -ELEMENTS[67446] = Fluid3D([8768,8855,9241,8232],0); -ELEMENTS[67447] = Fluid3D([9241,8768,8232,8243],0); -ELEMENTS[67448] = Fluid3D([8768,8855,8232,7611],0); -ELEMENTS[67449] = Fluid3D([16600,16955,16632,16194],0); -ELEMENTS[67450] = Fluid3D([5744,5745,6233,5747],0); -ELEMENTS[67451] = Fluid3D([16477,16906,17077,16634],0); -ELEMENTS[67452] = Fluid3D([10133,11009,10924,11204],0); -ELEMENTS[67453] = Fluid3D([3925,4260,4239,4409],0); -ELEMENTS[67454] = Fluid3D([4260,4239,4409,4463],0); -ELEMENTS[67455] = Fluid3D([17724,17852,17688,18094],0); -ELEMENTS[67456] = Fluid3D([16842,16760,16422,16029],0); -ELEMENTS[67457] = Fluid3D([15293,15043,15625,14546],0); -ELEMENTS[67458] = Fluid3D([6305,5652,5522,6152],0); -ELEMENTS[67459] = Fluid3D([18627,18561,18631,18586],0); -ELEMENTS[67460] = Fluid3D([18627,18561,18586,18638],0); -ELEMENTS[67461] = Fluid3D([13190,13705,13287,12803],0); -ELEMENTS[67462] = Fluid3D([13287,13190,12803,12234],0); -ELEMENTS[67463] = Fluid3D([12027,12917,12736,12745],0); -ELEMENTS[67464] = Fluid3D([2384,2263,2425,2680],0); -ELEMENTS[67465] = Fluid3D([18043,17683,17846,17708],0); -ELEMENTS[67466] = Fluid3D([11745,11299,12069,10956],0); -ELEMENTS[67467] = Fluid3D([11745,11299,10956,10743],0); -ELEMENTS[67468] = Fluid3D([12214,12900,12646,13097],0); -ELEMENTS[67469] = Fluid3D([18125,17911,17914,18013],0); -ELEMENTS[67470] = Fluid3D([18125,17911,18013,18102],0); -ELEMENTS[67471] = Fluid3D([17914,18125,18013,18094],0); -ELEMENTS[67472] = Fluid3D([18125,18013,18094,18212],0); -ELEMENTS[67473] = Fluid3D([18013,18094,18212,17852],0); -ELEMENTS[67474] = Fluid3D([18013,18094,17852,17724],0); -ELEMENTS[67475] = Fluid3D([17852,18013,17724,18102],0); -ELEMENTS[67476] = Fluid3D([17852,18013,18102,18212],0); -ELEMENTS[67477] = Fluid3D([18013,18094,17724,17914],0); -ELEMENTS[67478] = Fluid3D([17724,18013,17914,17911],0); -ELEMENTS[67479] = Fluid3D([17724,18013,17911,18102],0); -ELEMENTS[67480] = Fluid3D([18013,18102,18212,18125],0); -ELEMENTS[67481] = Fluid3D([15282,14874,15116,15800],0); -ELEMENTS[67482] = Fluid3D([8608,8332,9368,8478],0); -ELEMENTS[67483] = Fluid3D([9368,8608,8478,8997],0); -ELEMENTS[67484] = Fluid3D([8608,8332,8478,7652],0); -ELEMENTS[67485] = Fluid3D([17214,17310,17628,17599],0); -ELEMENTS[67486] = Fluid3D([7491,7132,6349,6461],0); -ELEMENTS[67487] = Fluid3D([4493,4630,4509,4007],0); -ELEMENTS[67488] = Fluid3D([8708,8603,9402,8297],0); -ELEMENTS[67489] = Fluid3D([17962,17867,18070,17682],0); -ELEMENTS[67490] = Fluid3D([17962,17867,17682,17633],0); -ELEMENTS[67491] = Fluid3D([12014,12809,12801,12780],0); -ELEMENTS[67492] = Fluid3D([12014,12809,12780,12714],0); -ELEMENTS[67493] = Fluid3D([12809,12780,12714,13637],0); -ELEMENTS[67494] = Fluid3D([12780,12714,13637,12227],0); -ELEMENTS[67495] = Fluid3D([12780,12714,12227,12014],0); -ELEMENTS[67496] = Fluid3D([12227,12780,12014,12801],0); -ELEMENTS[67497] = Fluid3D([12227,12780,12801,13207],0); -ELEMENTS[67498] = Fluid3D([13637,12780,12227,13207],0); -ELEMENTS[67499] = Fluid3D([5306,4926,4756,4911],0); -ELEMENTS[67500] = Fluid3D([12644,12496,12961,11710],0); -ELEMENTS[67501] = Fluid3D([16922,17005,17327,17526],0); -ELEMENTS[67502] = Fluid3D([5429,5140,5032,5191],0); -ELEMENTS[67503] = Fluid3D([18197,18109,17934,18141],0); -ELEMENTS[67504] = Fluid3D([18197,18109,18141,18322],0); -ELEMENTS[67505] = Fluid3D([18109,18141,18322,17961],0); -ELEMENTS[67506] = Fluid3D([18109,18141,17961,17815],0); -ELEMENTS[67507] = Fluid3D([17961,18109,17815,17934],0); -ELEMENTS[67508] = Fluid3D([17961,18109,17934,18093],0); -ELEMENTS[67509] = Fluid3D([18109,17815,17934,18141],0); -ELEMENTS[67510] = Fluid3D([17815,17961,17934,17505],0); -ELEMENTS[67511] = Fluid3D([18322,18109,17961,18201],0); -ELEMENTS[67512] = Fluid3D([18109,17961,18201,18093],0); -ELEMENTS[67513] = Fluid3D([13381,12676,14056,13148],0); -ELEMENTS[67514] = Fluid3D([10558,10868,10284,11362],0); -ELEMENTS[67515] = Fluid3D([11049,11345,11740,12523],0); -ELEMENTS[67516] = Fluid3D([15242,14544,15288,15440],0); -ELEMENTS[67517] = Fluid3D([16531,16329,16156,15758],0); -ELEMENTS[67518] = Fluid3D([16838,17203,16578,16791],0); -ELEMENTS[67519] = Fluid3D([17135,16752,16640,16678],0); -ELEMENTS[67520] = Fluid3D([5017,4750,5152,5261],0); -ELEMENTS[67521] = Fluid3D([17528,17381,17097,17017],0); -ELEMENTS[67522] = Fluid3D([8875,8027,8180,8570],0); -ELEMENTS[67523] = Fluid3D([12988,13097,12036,12238],0); -ELEMENTS[67524] = Fluid3D([12036,12988,12238,12625],0); -ELEMENTS[67525] = Fluid3D([12988,13097,12238,13369],0); -ELEMENTS[67526] = Fluid3D([12988,13097,13369,13661],0); -ELEMENTS[67527] = Fluid3D([12988,12238,12625,11904],0); -ELEMENTS[67528] = Fluid3D([12625,12988,11904,12614],0); -ELEMENTS[67529] = Fluid3D([11904,12625,12614,13043],0); -ELEMENTS[67530] = Fluid3D([11904,12625,13043,12157],0); -ELEMENTS[67531] = Fluid3D([12625,13043,12157,13504],0); -ELEMENTS[67532] = Fluid3D([15382,15742,15034,15641],0); -ELEMENTS[67533] = Fluid3D([8066,7401,8686,7737],0); -ELEMENTS[67534] = Fluid3D([8686,8066,7737,9179],0); -ELEMENTS[67535] = Fluid3D([8066,7401,7737,6997],0); -ELEMENTS[67536] = Fluid3D([11610,12534,12421,11229],0); -ELEMENTS[67537] = Fluid3D([8946,8206,8910,8682],0); -ELEMENTS[67538] = Fluid3D([8580,8212,9063,8693],0); -ELEMENTS[67539] = Fluid3D([8903,8603,8297,9402],0); -ELEMENTS[67540] = Fluid3D([4996,4753,5063,5089],0); -ELEMENTS[67541] = Fluid3D([8122,8477,8885,7821],0); -ELEMENTS[67542] = Fluid3D([8122,8477,7821,7558],0); -ELEMENTS[67543] = Fluid3D([14209,13822,13401,13263],0); -ELEMENTS[67544] = Fluid3D([16260,16023,15992,16602],0); -ELEMENTS[67545] = Fluid3D([16260,16023,16602,16718],0); -ELEMENTS[67546] = Fluid3D([18526,18413,18550,18421],0); -ELEMENTS[67547] = Fluid3D([15508,15807,15682,16299],0); -ELEMENTS[67548] = Fluid3D([10820,11782,12040,11560],0); -ELEMENTS[67549] = Fluid3D([17250,17389,17374,16745],0); -ELEMENTS[67550] = Fluid3D([17634,17177,17383,17352],0); -ELEMENTS[67551] = Fluid3D([13475,14277,14460,13754],0); -ELEMENTS[67552] = Fluid3D([3942,4055,4584,4166],0); -ELEMENTS[67553] = Fluid3D([3181,3518,3646,3692],0); -ELEMENTS[67554] = Fluid3D([6283,6575,5805,5808],0); -ELEMENTS[67555] = Fluid3D([7065,6822,7701,7525],0); -ELEMENTS[67556] = Fluid3D([7065,6822,7525,6949],0); -ELEMENTS[67557] = Fluid3D([7065,6822,6949,6789],0); -ELEMENTS[67558] = Fluid3D([5215,5202,5447,5121],0); -ELEMENTS[67559] = Fluid3D([13936,13907,13058,13702],0); -ELEMENTS[67560] = Fluid3D([3844,4143,4039,3590],0); -ELEMENTS[67561] = Fluid3D([3844,4143,3590,3528],0); -ELEMENTS[67562] = Fluid3D([3954,3805,4494,3890],0); -ELEMENTS[67563] = Fluid3D([6714,6223,7061,6449],0); -ELEMENTS[67564] = Fluid3D([15549,15515,14856,14637],0); -ELEMENTS[67565] = Fluid3D([18288,18222,18369,18494],0); -ELEMENTS[67566] = Fluid3D([16152,16160,16532,16878],0); -ELEMENTS[67567] = Fluid3D([16475,16926,16805,17045],0); -ELEMENTS[67568] = Fluid3D([12161,11744,11704,12783],0); -ELEMENTS[67569] = Fluid3D([18063,18274,18004,18360],0); -ELEMENTS[67570] = Fluid3D([14403,14837,13964,13716],0); -ELEMENTS[67571] = Fluid3D([17025,16769,16373,16773],0); -ELEMENTS[67572] = Fluid3D([17025,16769,16773,17143],0); -ELEMENTS[67573] = Fluid3D([16773,17025,17143,17366],0); -ELEMENTS[67574] = Fluid3D([3752,3673,4190,4126],0); -ELEMENTS[67575] = Fluid3D([11669,11458,10558,11362],0); -ELEMENTS[67576] = Fluid3D([8708,9894,9402,9252],0); -ELEMENTS[67577] = Fluid3D([16855,16767,17074,16514],0); -ELEMENTS[67578] = Fluid3D([15282,15812,15800,15116],0); -ELEMENTS[67579] = Fluid3D([9285,9545,8961,8882],0); -ELEMENTS[67580] = Fluid3D([9285,9545,8882,9208],0); -ELEMENTS[67581] = Fluid3D([9285,9545,9208,10470],0); -ELEMENTS[67582] = Fluid3D([9545,8961,8882,10185],0); -ELEMENTS[67583] = Fluid3D([8882,9545,10185,9898],0); -ELEMENTS[67584] = Fluid3D([8882,9545,9898,9208],0); -ELEMENTS[67585] = Fluid3D([9545,10185,9898,10651],0); -ELEMENTS[67586] = Fluid3D([7821,8265,8389,7871],0); -ELEMENTS[67587] = Fluid3D([9794,9993,11038,10368],0); -ELEMENTS[67588] = Fluid3D([12643,12288,13322,12886],0); -ELEMENTS[67589] = Fluid3D([3090,2979,2962,3292],0); -ELEMENTS[67590] = Fluid3D([13165,13678,12936,12823],0); -ELEMENTS[67591] = Fluid3D([9510,8919,9217,9962],0); -ELEMENTS[67592] = Fluid3D([2860,3156,2963,2680],0); -ELEMENTS[67593] = Fluid3D([15209,15230,14621,14572],0); -ELEMENTS[67594] = Fluid3D([9963,11013,10679,9591],0); -ELEMENTS[67595] = Fluid3D([12662,11689,12629,11668],0); -ELEMENTS[67596] = Fluid3D([17980,18060,17966,18238],0); -ELEMENTS[67597] = Fluid3D([8530,8923,8514,9334],0); -ELEMENTS[67598] = Fluid3D([2289,2438,2186,2143],0); -ELEMENTS[67599] = Fluid3D([2292,2440,2531,2338],0); -ELEMENTS[67600] = Fluid3D([12642,11927,11896,11676],0); -ELEMENTS[67601] = Fluid3D([3814,3450,3490,3746],0); -ELEMENTS[67602] = Fluid3D([3781,3594,3328,3716],0); -ELEMENTS[67603] = Fluid3D([3018,2844,2699,2738],0); -ELEMENTS[67604] = Fluid3D([9341,9082,8883,9859],0); -ELEMENTS[67605] = Fluid3D([9082,8883,9859,9279],0); -ELEMENTS[67606] = Fluid3D([9409,8459,8498,9400],0); -ELEMENTS[67607] = Fluid3D([3553,3284,3879,3683],0); -ELEMENTS[67608] = Fluid3D([3362,3198,2969,3077],0); -ELEMENTS[67609] = Fluid3D([3362,3198,3077,3437],0); -ELEMENTS[67610] = Fluid3D([8740,9169,7826,8222],0); -ELEMENTS[67611] = Fluid3D([13268,13698,12761,12719],0); -ELEMENTS[67612] = Fluid3D([17572,17715,17915,17953],0); -ELEMENTS[67613] = Fluid3D([15939,15933,16305,16499],0); -ELEMENTS[67614] = Fluid3D([16305,15939,16499,16097],0); -ELEMENTS[67615] = Fluid3D([11446,11021,12025,10619],0); -ELEMENTS[67616] = Fluid3D([11322,12037,12462,11876],0); -ELEMENTS[67617] = Fluid3D([5743,5889,5402,5091],0); -ELEMENTS[67618] = Fluid3D([8488,8439,8891,7614],0); -ELEMENTS[67619] = Fluid3D([13758,12555,13575,12468],0); -ELEMENTS[67620] = Fluid3D([16090,16406,15812,16120],0); -ELEMENTS[67621] = Fluid3D([15936,15944,16368,15768],0); -ELEMENTS[67622] = Fluid3D([7142,6554,7657,7042],0); -ELEMENTS[67623] = Fluid3D([11867,11581,11224,12033],0); -ELEMENTS[67624] = Fluid3D([13322,12907,13593,13815],0); -ELEMENTS[67625] = Fluid3D([8867,8137,8376,8015],0); -ELEMENTS[67626] = Fluid3D([15528,15315,15692,16020],0); -ELEMENTS[67627] = Fluid3D([18053,17983,18120,17767],0); -ELEMENTS[67628] = Fluid3D([5649,6338,5834,6350],0); -ELEMENTS[67629] = Fluid3D([5649,6338,6350,5882],0); -ELEMENTS[67630] = Fluid3D([6338,6350,5882,6808],0); -ELEMENTS[67631] = Fluid3D([6338,6350,6808,7275],0); -ELEMENTS[67632] = Fluid3D([6338,6350,7275,6682],0); -ELEMENTS[67633] = Fluid3D([6338,6350,6682,5834],0); -ELEMENTS[67634] = Fluid3D([18297,18470,18347,18374],0); -ELEMENTS[67635] = Fluid3D([11050,11555,12072,11205],0); -ELEMENTS[67636] = Fluid3D([14131,14874,14397,14713],0); -ELEMENTS[67637] = Fluid3D([14438,13681,14622,14258],0); -ELEMENTS[67638] = Fluid3D([15499,15363,15502,14952],0); -ELEMENTS[67639] = Fluid3D([13786,14370,13646,14307],0); -ELEMENTS[67640] = Fluid3D([13646,13786,14307,13278],0); -ELEMENTS[67641] = Fluid3D([5422,4923,5345,5206],0); -ELEMENTS[67642] = Fluid3D([7825,7235,7874,7140],0); -ELEMENTS[67643] = Fluid3D([11488,11876,12721,11220],0); -ELEMENTS[67644] = Fluid3D([3438,3514,3863,3247],0); -ELEMENTS[67645] = Fluid3D([3438,3514,3247,3075],0); -ELEMENTS[67646] = Fluid3D([2955,3253,2931,3458],0); -ELEMENTS[67647] = Fluid3D([3988,4182,4601,4204],0); -ELEMENTS[67648] = Fluid3D([12472,12711,11832,11229],0); -ELEMENTS[67649] = Fluid3D([11832,12472,11229,11908],0); -ELEMENTS[67650] = Fluid3D([11433,11230,11397,10467],0); -ELEMENTS[67651] = Fluid3D([8335,8177,8145,7305],0); -ELEMENTS[67652] = Fluid3D([15751,16041,15823,15302],0); -ELEMENTS[67653] = Fluid3D([5329,5932,5454,5562],0); -ELEMENTS[67654] = Fluid3D([9228,9608,8666,10048],0); -ELEMENTS[67655] = Fluid3D([9228,9608,10048,9696],0); -ELEMENTS[67656] = Fluid3D([10048,9228,9696,9328],0); -ELEMENTS[67657] = Fluid3D([9228,9608,9696,9264],0); -ELEMENTS[67658] = Fluid3D([9696,9228,9264,8355],0); -ELEMENTS[67659] = Fluid3D([9228,9608,9264,8522],0); -ELEMENTS[67660] = Fluid3D([9228,9264,8355,8522],0); -ELEMENTS[67661] = Fluid3D([9264,8355,8522,9505],0); -ELEMENTS[67662] = Fluid3D([9264,8355,9505,9051],0); -ELEMENTS[67663] = Fluid3D([9264,8355,9051,9696],0); -ELEMENTS[67664] = Fluid3D([8522,9264,9505,9751],0); -ELEMENTS[67665] = Fluid3D([9264,9505,9751,10540],0); -ELEMENTS[67666] = Fluid3D([8522,9264,9751,9608],0); -ELEMENTS[67667] = Fluid3D([9264,9751,9608,9696],0); -ELEMENTS[67668] = Fluid3D([9264,9751,9696,10540],0); -ELEMENTS[67669] = Fluid3D([5699,6263,5974,6152],0); -ELEMENTS[67670] = Fluid3D([13416,13301,13869,14483],0); -ELEMENTS[67671] = Fluid3D([6516,6298,5985,5592],0); -ELEMENTS[67672] = Fluid3D([5985,6516,5592,5694],0); -ELEMENTS[67673] = Fluid3D([5592,5985,5694,5368],0); -ELEMENTS[67674] = Fluid3D([4975,5482,5622,4965],0); -ELEMENTS[67675] = Fluid3D([9990,9074,9368,8794],0); -ELEMENTS[67676] = Fluid3D([5084,4471,4489,4871],0); -ELEMENTS[67677] = Fluid3D([4471,4489,4871,4131],0); -ELEMENTS[67678] = Fluid3D([4489,5084,4871,5218],0); -ELEMENTS[67679] = Fluid3D([5084,4871,5218,5598],0); -ELEMENTS[67680] = Fluid3D([4871,4489,5218,4897],0); -ELEMENTS[67681] = Fluid3D([4871,4489,4897,4442],0); -ELEMENTS[67682] = Fluid3D([5218,4871,4897,5445],0); -ELEMENTS[67683] = Fluid3D([11114,10094,10345,10893],0); -ELEMENTS[67684] = Fluid3D([18186,18415,18359,18314],0); -ELEMENTS[67685] = Fluid3D([16017,15987,16566,15860],0); -ELEMENTS[67686] = Fluid3D([16017,15987,15860,15352],0); -ELEMENTS[67687] = Fluid3D([11272,10343,11483,10946],0); -ELEMENTS[67688] = Fluid3D([16298,16352,16621,16774],0); -ELEMENTS[67689] = Fluid3D([16298,16352,16774,16494],0); -ELEMENTS[67690] = Fluid3D([16621,16298,16774,16494],0); -ELEMENTS[67691] = Fluid3D([4424,4318,4267,3856],0); -ELEMENTS[67692] = Fluid3D([9744,8925,9396,8375],0); -ELEMENTS[67693] = Fluid3D([5858,6120,5406,5994],0); -ELEMENTS[67694] = Fluid3D([5406,5858,5994,5475],0); -ELEMENTS[67695] = Fluid3D([5994,5406,5475,5545],0); -ELEMENTS[67696] = Fluid3D([13843,12856,13867,12568],0); -ELEMENTS[67697] = Fluid3D([6244,5917,6646,6023],0); -ELEMENTS[67698] = Fluid3D([10362,11275,10465,9710],0); -ELEMENTS[67699] = Fluid3D([11095,11057,10372,9935],0); -ELEMENTS[67700] = Fluid3D([11095,11057,9935,10553],0); -ELEMENTS[67701] = Fluid3D([3767,4127,4029,3611],0); -ELEMENTS[67702] = Fluid3D([3767,4127,3611,3851],0); -ELEMENTS[67703] = Fluid3D([9011,8934,7966,7983],0); -ELEMENTS[67704] = Fluid3D([13226,12280,13098,12808],0); -ELEMENTS[67705] = Fluid3D([13226,12280,12808,13017],0); -ELEMENTS[67706] = Fluid3D([6182,6553,5752,6034],0); -ELEMENTS[67707] = Fluid3D([7916,7610,6935,7791],0); -ELEMENTS[67708] = Fluid3D([4193,3957,4132,4840],0); -ELEMENTS[67709] = Fluid3D([4219,4389,4091,3839],0); -ELEMENTS[67710] = Fluid3D([11048,11560,10820,12040],0); -ELEMENTS[67711] = Fluid3D([4742,5105,5106,5612],0); -ELEMENTS[67712] = Fluid3D([8981,8348,8790,9678],0); -ELEMENTS[67713] = Fluid3D([3731,3881,3563,4067],0); -ELEMENTS[67714] = Fluid3D([18433,18365,18503,18391],0); -ELEMENTS[67715] = Fluid3D([10922,11624,12052,11662],0); -ELEMENTS[67716] = Fluid3D([15165,15162,15188,15852],0); -ELEMENTS[67717] = Fluid3D([9793,8784,8846,9152],0); -ELEMENTS[67718] = Fluid3D([3772,3494,4003,4136],0); -ELEMENTS[67719] = Fluid3D([7459,7483,7442,7886],0); -ELEMENTS[67720] = Fluid3D([7483,7442,7886,6643],0); -ELEMENTS[67721] = Fluid3D([15675,15449,15304,15766],0); -ELEMENTS[67722] = Fluid3D([15675,15449,15766,16293],0); -ELEMENTS[67723] = Fluid3D([15766,15675,16293,16236],0); -ELEMENTS[67724] = Fluid3D([16293,15766,16236,15880],0); -ELEMENTS[67725] = Fluid3D([15766,16236,15880,15304],0); -ELEMENTS[67726] = Fluid3D([16293,15766,15880,15461],0); -ELEMENTS[67727] = Fluid3D([15766,15880,15461,15095],0); -ELEMENTS[67728] = Fluid3D([15461,15766,15095,15895],0); -ELEMENTS[67729] = Fluid3D([15880,15461,15095,14915],0); -ELEMENTS[67730] = Fluid3D([15461,15095,14915,15031],0); -ELEMENTS[67731] = Fluid3D([15461,15095,15031,15183],0); -ELEMENTS[67732] = Fluid3D([15461,15095,15183,15895],0); -ELEMENTS[67733] = Fluid3D([15304,15675,15766,16236],0); -ELEMENTS[67734] = Fluid3D([15766,15880,15095,15304],0); -ELEMENTS[67735] = Fluid3D([15095,15766,15304,15449],0); -ELEMENTS[67736] = Fluid3D([15095,15766,15449,15895],0); -ELEMENTS[67737] = Fluid3D([15766,15449,15895,16293],0); -ELEMENTS[67738] = Fluid3D([15895,15766,16293,15461],0); -ELEMENTS[67739] = Fluid3D([15267,15870,15865,15572],0); -ELEMENTS[67740] = Fluid3D([4976,5488,5485,4839],0); -ELEMENTS[67741] = Fluid3D([14514,14166,13866,14605],0); -ELEMENTS[67742] = Fluid3D([2914,2957,3149,2898],0); -ELEMENTS[67743] = Fluid3D([15877,16201,15716,15927],0); -ELEMENTS[67744] = Fluid3D([2710,2490,2296,2391],0); -ELEMENTS[67745] = Fluid3D([5808,5561,4998,5118],0); -ELEMENTS[67746] = Fluid3D([9410,9567,10696,10599],0); -ELEMENTS[67747] = Fluid3D([10953,10154,11002,10712],0); -ELEMENTS[67748] = Fluid3D([11174,11604,10089,11149],0); -ELEMENTS[67749] = Fluid3D([11174,11604,11149,11429],0); -ELEMENTS[67750] = Fluid3D([17625,17380,17164,17569],0); -ELEMENTS[67751] = Fluid3D([9701,8911,8722,9259],0); -ELEMENTS[67752] = Fluid3D([3956,3721,4144,4448],0); -ELEMENTS[67753] = Fluid3D([2831,2507,2803,2788],0); -ELEMENTS[67754] = Fluid3D([2803,2831,2788,3128],0); -ELEMENTS[67755] = Fluid3D([12996,12993,12377,13274],0); -ELEMENTS[67756] = Fluid3D([16555,16725,17194,16997],0); -ELEMENTS[67757] = Fluid3D([4128,4282,4655,4768],0); -ELEMENTS[67758] = Fluid3D([13075,13645,12555,13575],0); -ELEMENTS[67759] = Fluid3D([4182,4340,4414,4035],0); -ELEMENTS[67760] = Fluid3D([4340,4414,4035,4318],0); -ELEMENTS[67761] = Fluid3D([4182,4340,4035,3717],0); -ELEMENTS[67762] = Fluid3D([4182,4340,3717,3945],0); -ELEMENTS[67763] = Fluid3D([4340,4035,3717,4267],0); -ELEMENTS[67764] = Fluid3D([17571,17642,17356,17107],0); -ELEMENTS[67765] = Fluid3D([13184,14051,13275,13732],0); -ELEMENTS[67766] = Fluid3D([13275,13184,13732,12875],0); -ELEMENTS[67767] = Fluid3D([14720,15185,14922,14161],0); -ELEMENTS[67768] = Fluid3D([12020,11326,12180,12524],0); -ELEMENTS[67769] = Fluid3D([3973,3525,4016,3383],0); -ELEMENTS[67770] = Fluid3D([3244,3415,3573,3114],0); -ELEMENTS[67771] = Fluid3D([3244,3415,3114,2854],0); -ELEMENTS[67772] = Fluid3D([15077,14958,14374,15262],0); -ELEMENTS[67773] = Fluid3D([4617,4837,5214,5372],0); -ELEMENTS[67774] = Fluid3D([4837,5214,5372,5322],0); -ELEMENTS[67775] = Fluid3D([16456,16661,16591,16929],0); -ELEMENTS[67776] = Fluid3D([16456,16661,16929,16669],0); -ELEMENTS[67777] = Fluid3D([16661,16591,16929,17160],0); -ELEMENTS[67778] = Fluid3D([16591,16456,16929,16893],0); -ELEMENTS[67779] = Fluid3D([18231,18350,18469,18340],0); -ELEMENTS[67780] = Fluid3D([3965,4499,4306,4776],0); -ELEMENTS[67781] = Fluid3D([17069,16718,16781,17100],0); -ELEMENTS[67782] = Fluid3D([15808,15592,15305,15906],0); -ELEMENTS[67783] = Fluid3D([12674,12354,12047,12246],0); -ELEMENTS[67784] = Fluid3D([3842,3839,3794,4467],0); -ELEMENTS[67785] = Fluid3D([9061,9629,8620,8820],0); -ELEMENTS[67786] = Fluid3D([12036,12238,11014,11904],0); -ELEMENTS[67787] = Fluid3D([5184,4811,4540,4463],0); -ELEMENTS[67788] = Fluid3D([14004,13919,14701,13509],0); -ELEMENTS[67789] = Fluid3D([12368,12798,12363,11418],0); -ELEMENTS[67790] = Fluid3D([18450,18586,18535,18478],0); -ELEMENTS[67791] = Fluid3D([13931,13865,13469,13409],0); -ELEMENTS[67792] = Fluid3D([14728,14219,14158,14416],0); -ELEMENTS[67793] = Fluid3D([3245,3256,3639,3158],0); -ELEMENTS[67794] = Fluid3D([4206,3807,4039,3829],0); -ELEMENTS[67795] = Fluid3D([11814,11289,11984,12617],0); -ELEMENTS[67796] = Fluid3D([13091,12694,12050,11708],0); -ELEMENTS[67797] = Fluid3D([11091,10359,11397,9882],0); -ELEMENTS[67798] = Fluid3D([6726,6555,5848,5928],0); -ELEMENTS[67799] = Fluid3D([6726,6555,5928,6229],0); -ELEMENTS[67800] = Fluid3D([12100,11741,11498,11089],0); -ELEMENTS[67801] = Fluid3D([17230,17404,17630,17392],0); -ELEMENTS[67802] = Fluid3D([17630,17230,17392,17048],0); -ELEMENTS[67803] = Fluid3D([11185,12180,11783,12126],0); -ELEMENTS[67804] = Fluid3D([7213,7011,6534,6347],0); -ELEMENTS[67805] = Fluid3D([7011,6534,6347,6650],0); -ELEMENTS[67806] = Fluid3D([7213,7011,6347,6650],0); -ELEMENTS[67807] = Fluid3D([15066,15477,15396,15402],0); -ELEMENTS[67808] = Fluid3D([15066,15477,15402,14540],0); -ELEMENTS[67809] = Fluid3D([15396,15066,15402,14391],0); -ELEMENTS[67810] = Fluid3D([11402,11941,12329,12461],0); -ELEMENTS[67811] = Fluid3D([12206,12839,13099,13618],0); -ELEMENTS[67812] = Fluid3D([10308,10383,10871,11358],0); -ELEMENTS[67813] = Fluid3D([10308,10383,11358,10613],0); -ELEMENTS[67814] = Fluid3D([9834,9093,10153,10313],0); -ELEMENTS[67815] = Fluid3D([11622,12110,12816,11699],0); -ELEMENTS[67816] = Fluid3D([8452,8908,8271,9697],0); -ELEMENTS[67817] = Fluid3D([2109,1959,1849,1966],0); -ELEMENTS[67818] = Fluid3D([1959,1849,1966,1807],0); -ELEMENTS[67819] = Fluid3D([18267,18005,18256,18181],0); -ELEMENTS[67820] = Fluid3D([4811,5396,5002,5682],0); -ELEMENTS[67821] = Fluid3D([6014,6316,5601,5783],0); -ELEMENTS[67822] = Fluid3D([17978,17936,18067,18101],0); -ELEMENTS[67823] = Fluid3D([18067,17978,18101,18276],0); -ELEMENTS[67824] = Fluid3D([17978,17936,18101,18264],0); -ELEMENTS[67825] = Fluid3D([17978,18101,18276,18264],0); -ELEMENTS[67826] = Fluid3D([13468,13938,13284,13515],0); -ELEMENTS[67827] = Fluid3D([16467,16189,16896,16799],0); -ELEMENTS[67828] = Fluid3D([10195,10144,10581,11307],0); -ELEMENTS[67829] = Fluid3D([9358,9464,10119,10531],0); -ELEMENTS[67830] = Fluid3D([4769,4290,4726,4859],0); -ELEMENTS[67831] = Fluid3D([4134,3828,4007,3755],0); -ELEMENTS[67832] = Fluid3D([15531,15562,15513,14783],0); -ELEMENTS[67833] = Fluid3D([7489,6920,7458,7717],0); -ELEMENTS[67834] = Fluid3D([15217,15559,15906,16077],0); -ELEMENTS[67835] = Fluid3D([3560,3874,3982,4359],0); -ELEMENTS[67836] = Fluid3D([13584,13265,12644,13196],0); -ELEMENTS[67837] = Fluid3D([12377,12238,11954,12646],0); -ELEMENTS[67838] = Fluid3D([6086,5985,6298,5555],0); -ELEMENTS[67839] = Fluid3D([7198,7588,7225,6421],0); -ELEMENTS[67840] = Fluid3D([15274,15348,14847,14710],0); -ELEMENTS[67841] = Fluid3D([10066,9619,9824,10414],0); -ELEMENTS[67842] = Fluid3D([8473,9091,8575,7983],0); -ELEMENTS[67843] = Fluid3D([15179,15202,14870,14467],0); -ELEMENTS[67844] = Fluid3D([6366,6770,6641,6696],0); -ELEMENTS[67845] = Fluid3D([15484,14805,15385,14820],0); -ELEMENTS[67846] = Fluid3D([15484,14805,14820,15120],0); -ELEMENTS[67847] = Fluid3D([14412,14057,14239,13405],0); -ELEMENTS[67848] = Fluid3D([13455,12983,13372,12568],0); -ELEMENTS[67849] = Fluid3D([5132,4683,4811,4463],0); -ELEMENTS[67850] = Fluid3D([9642,8757,8865,8706],0); -ELEMENTS[67851] = Fluid3D([9642,8757,8706,9353],0); -ELEMENTS[67852] = Fluid3D([3911,4292,3835,3523],0); -ELEMENTS[67853] = Fluid3D([17785,17919,18002,18193],0); -ELEMENTS[67854] = Fluid3D([10813,9966,11316,11325],0); -ELEMENTS[67855] = Fluid3D([5406,5632,5545,5994],0); -ELEMENTS[67856] = Fluid3D([5406,5632,5994,6120],0); -ELEMENTS[67857] = Fluid3D([6817,7157,6722,7927],0); -ELEMENTS[67858] = Fluid3D([16889,16836,16423,16192],0); -ELEMENTS[67859] = Fluid3D([7025,8048,7661,6988],0); -ELEMENTS[67860] = Fluid3D([17242,16857,17322,17026],0); -ELEMENTS[67861] = Fluid3D([17322,17242,17026,17570],0); -ELEMENTS[67862] = Fluid3D([14270,14674,14865,14843],0); -ELEMENTS[67863] = Fluid3D([14674,14865,14843,15659],0); -ELEMENTS[67864] = Fluid3D([9446,9824,9209,9734],0); -ELEMENTS[67865] = Fluid3D([9359,8804,8640,9175],0); -ELEMENTS[67866] = Fluid3D([10304,9996,9457,9139],0); -ELEMENTS[67867] = Fluid3D([3651,4025,3386,3768],0); -ELEMENTS[67868] = Fluid3D([16005,16236,15675,15304],0); -ELEMENTS[67869] = Fluid3D([14851,15596,15126,15897],0); -ELEMENTS[67870] = Fluid3D([15596,15126,15897,15557],0); -ELEMENTS[67871] = Fluid3D([12179,12101,11045,11698],0); -ELEMENTS[67872] = Fluid3D([15265,14765,14885,14580],0); -ELEMENTS[67873] = Fluid3D([7512,7024,7416,8054],0); -ELEMENTS[67874] = Fluid3D([16470,16657,15885,15851],0); -ELEMENTS[67875] = Fluid3D([10308,10337,10613,11358],0); -ELEMENTS[67876] = Fluid3D([9967,10622,9281,10121],0); -ELEMENTS[67877] = Fluid3D([9967,10622,10121,10108],0); -ELEMENTS[67878] = Fluid3D([3912,4170,4507,4263],0); -ELEMENTS[67879] = Fluid3D([4170,4507,4263,4758],0); -ELEMENTS[67880] = Fluid3D([18613,18628,18535,18518],0); -ELEMENTS[67881] = Fluid3D([4105,4641,4318,4449],0); -ELEMENTS[67882] = Fluid3D([5733,5409,6034,5853],0); -ELEMENTS[67883] = Fluid3D([2760,2830,3138,3155],0); -ELEMENTS[67884] = Fluid3D([12426,11457,11170,11669],0); -ELEMENTS[67885] = Fluid3D([11457,11170,11669,10889],0); -ELEMENTS[67886] = Fluid3D([11457,11170,10889,10108],0); -ELEMENTS[67887] = Fluid3D([11669,11457,10889,11966],0); -ELEMENTS[67888] = Fluid3D([11669,11457,11966,12426],0); -ELEMENTS[67889] = Fluid3D([11966,11669,12426,13126],0); -ELEMENTS[67890] = Fluid3D([11457,10889,11966,11630],0); -ELEMENTS[67891] = Fluid3D([11457,10889,11630,11541],0); -ELEMENTS[67892] = Fluid3D([11457,10889,11541,10622],0); -ELEMENTS[67893] = Fluid3D([9598,9949,9728,10980],0); -ELEMENTS[67894] = Fluid3D([2659,3010,2936,2889],0); -ELEMENTS[67895] = Fluid3D([3010,2936,2889,3401],0); -ELEMENTS[67896] = Fluid3D([6300,6955,6126,6320],0); -ELEMENTS[67897] = Fluid3D([3357,2964,3064,3351],0); -ELEMENTS[67898] = Fluid3D([13760,13548,14528,14194],0); -ELEMENTS[67899] = Fluid3D([7015,6908,6067,6875],0); -ELEMENTS[67900] = Fluid3D([4797,4422,4600,4371],0); -ELEMENTS[67901] = Fluid3D([5057,4423,4305,4802],0); -ELEMENTS[67902] = Fluid3D([4423,4305,4802,3970],0); -ELEMENTS[67903] = Fluid3D([4423,4305,3970,3877],0); -ELEMENTS[67904] = Fluid3D([4423,4305,3877,4181],0); -ELEMENTS[67905] = Fluid3D([3982,3829,4206,4039],0); -ELEMENTS[67906] = Fluid3D([12401,11766,11369,12729],0); -ELEMENTS[67907] = Fluid3D([7142,6707,7599,7582],0); -ELEMENTS[67908] = Fluid3D([10987,11235,11158,10605],0); -ELEMENTS[67909] = Fluid3D([7063,7167,8161,7623],0); -ELEMENTS[67910] = Fluid3D([5984,6627,6206,6803],0); -ELEMENTS[67911] = Fluid3D([6206,5984,6803,5812],0); -ELEMENTS[67912] = Fluid3D([15638,15596,14997,14868],0); -ELEMENTS[67913] = Fluid3D([13925,13334,13321,14284],0); -ELEMENTS[67914] = Fluid3D([13321,13925,14284,14175],0); -ELEMENTS[67915] = Fluid3D([4159,3799,4240,4140],0); -ELEMENTS[67916] = Fluid3D([15762,16088,16176,16558],0); -ELEMENTS[67917] = Fluid3D([16437,16069,16514,16619],0); -ELEMENTS[67918] = Fluid3D([3355,3517,3180,3191],0); -ELEMENTS[67919] = Fluid3D([6523,6797,7372,6855],0); -ELEMENTS[67920] = Fluid3D([4589,4215,4141,4691],0); -ELEMENTS[67921] = Fluid3D([4215,4141,4691,4743],0); -ELEMENTS[67922] = Fluid3D([14129,14100,15040,14663],0); -ELEMENTS[67923] = Fluid3D([18391,18335,18380,18418],0); -ELEMENTS[67924] = Fluid3D([2783,2653,2768,3032],0); -ELEMENTS[67925] = Fluid3D([2651,2403,2349,2449],0); -ELEMENTS[67926] = Fluid3D([8097,7285,8333,7569],0); -ELEMENTS[67927] = Fluid3D([16425,16897,16825,16865],0); -ELEMENTS[67928] = Fluid3D([2940,2816,2630,3191],0); -ELEMENTS[67929] = Fluid3D([2940,2816,3191,3180],0); -ELEMENTS[67930] = Fluid3D([3292,3649,3306,3090],0); -ELEMENTS[67931] = Fluid3D([17937,17853,17595,17658],0); -ELEMENTS[67932] = Fluid3D([17937,17853,17658,18066],0); -ELEMENTS[67933] = Fluid3D([18094,17966,17852,17688],0); -ELEMENTS[67934] = Fluid3D([8265,8885,8389,8863],0); -ELEMENTS[67935] = Fluid3D([6898,7135,7717,7641],0); -ELEMENTS[67936] = Fluid3D([2229,2041,2215,2300],0); -ELEMENTS[67937] = Fluid3D([17009,16451,16922,16828],0); -ELEMENTS[67938] = Fluid3D([16922,17009,16828,17005],0); -ELEMENTS[67939] = Fluid3D([16922,17009,17005,17526],0); -ELEMENTS[67940] = Fluid3D([13400,13600,12815,13491],0); -ELEMENTS[67941] = Fluid3D([10283,10134,9894,9252],0); -ELEMENTS[67942] = Fluid3D([6942,6421,7198,6162],0); -ELEMENTS[67943] = Fluid3D([7268,6961,6777,7561],0); -ELEMENTS[67944] = Fluid3D([15666,16072,16165,16353],0); -ELEMENTS[67945] = Fluid3D([3071,3575,3410,3025],0); -ELEMENTS[67946] = Fluid3D([3410,3071,3025,2954],0); -ELEMENTS[67947] = Fluid3D([8737,8692,8585,9620],0); -ELEMENTS[67948] = Fluid3D([9223,8708,9402,8890],0); -ELEMENTS[67949] = Fluid3D([15494,15904,15169,15214],0); -ELEMENTS[67950] = Fluid3D([10241,9357,9493,10145],0); -ELEMENTS[67951] = Fluid3D([8268,8818,9226,8208],0); -ELEMENTS[67952] = Fluid3D([15440,15607,14992,14720],0); -ELEMENTS[67953] = Fluid3D([15825,15794,15492,16425],0); -ELEMENTS[67954] = Fluid3D([14653,15369,15204,14585],0); -ELEMENTS[67955] = Fluid3D([17607,17267,17105,17317],0); -ELEMENTS[67956] = Fluid3D([17267,17105,17317,16897],0); -ELEMENTS[67957] = Fluid3D([17317,17267,16897,17333],0); -ELEMENTS[67958] = Fluid3D([17105,17317,16897,17301],0); -ELEMENTS[67959] = Fluid3D([17317,17267,17333,17616],0); -ELEMENTS[67960] = Fluid3D([17267,17333,17616,17221],0); -ELEMENTS[67961] = Fluid3D([17607,17267,17317,17616],0); -ELEMENTS[67962] = Fluid3D([7662,7107,6797,7372],0); -ELEMENTS[67963] = Fluid3D([6797,7662,7372,7647],0); -ELEMENTS[67964] = Fluid3D([2816,2374,2529,2721],0); -ELEMENTS[67965] = Fluid3D([13125,12441,12150,11855],0); -ELEMENTS[67966] = Fluid3D([15256,15496,15785,15079],0); -ELEMENTS[67967] = Fluid3D([7600,6668,6941,7260],0); -ELEMENTS[67968] = Fluid3D([5348,5493,5273,5719],0); -ELEMENTS[67969] = Fluid3D([13867,13372,13843,12568],0); -ELEMENTS[67970] = Fluid3D([6721,7082,7581,7364],0); -ELEMENTS[67971] = Fluid3D([7326,7443,8257,8745],0); -ELEMENTS[67972] = Fluid3D([5674,6150,6013,6653],0); -ELEMENTS[67973] = Fluid3D([6013,5674,6653,6134],0); -ELEMENTS[67974] = Fluid3D([11051,10363,10018,10382],0); -ELEMENTS[67975] = Fluid3D([13776,14126,13295,14696],0); -ELEMENTS[67976] = Fluid3D([9785,9459,9260,9973],0); -ELEMENTS[67977] = Fluid3D([10469,10376,10337,11310],0); -ELEMENTS[67978] = Fluid3D([10469,10376,11310,11421],0); -ELEMENTS[67979] = Fluid3D([10376,11310,11421,11488],0); -ELEMENTS[67980] = Fluid3D([11310,11421,11488,12144],0); -ELEMENTS[67981] = Fluid3D([1836,1985,1862,1870],0); -ELEMENTS[67982] = Fluid3D([7277,7741,8311,7190],0); -ELEMENTS[67983] = Fluid3D([7277,7741,7190,7078],0); -ELEMENTS[67984] = Fluid3D([16820,16868,16313,16541],0); -ELEMENTS[67985] = Fluid3D([11932,12944,12767,11997],0); -ELEMENTS[67986] = Fluid3D([12308,11791,11401,11692],0); -ELEMENTS[67987] = Fluid3D([6444,7163,6414,6886],0); -ELEMENTS[67988] = Fluid3D([10860,11521,11280,11240],0); -ELEMENTS[67989] = Fluid3D([17289,17492,17645,17560],0); -ELEMENTS[67990] = Fluid3D([13581,13649,12967,13918],0); -ELEMENTS[67991] = Fluid3D([14601,14498,13829,13369],0); -ELEMENTS[67992] = Fluid3D([3597,3316,3696,3971],0); -ELEMENTS[67993] = Fluid3D([13490,13955,14391,14444],0); -ELEMENTS[67994] = Fluid3D([6897,7763,7091,7242],0); -ELEMENTS[67995] = Fluid3D([8880,8505,8770,7818],0); -ELEMENTS[67996] = Fluid3D([11369,11766,10912,11686],0); -ELEMENTS[67997] = Fluid3D([11369,11766,11686,12729],0); -ELEMENTS[67998] = Fluid3D([14742,14854,15459,14933],0); -ELEMENTS[67999] = Fluid3D([14742,14854,14933,13822],0); -ELEMENTS[68000] = Fluid3D([16111,15525,15932,15369],0); -ELEMENTS[68001] = Fluid3D([4212,3751,4040,3805],0); -ELEMENTS[68002] = Fluid3D([14191,13542,14516,14180],0); -ELEMENTS[68003] = Fluid3D([14191,13542,14180,14049],0); -ELEMENTS[68004] = Fluid3D([18623,18583,18591,18644],0); -ELEMENTS[68005] = Fluid3D([12569,12141,12056,12623],0); -ELEMENTS[68006] = Fluid3D([2753,3065,2931,3011],0); -ELEMENTS[68007] = Fluid3D([6030,6308,5398,5818],0); -ELEMENTS[68008] = Fluid3D([6030,6308,5818,5609],0); -ELEMENTS[68009] = Fluid3D([14252,14582,14309,14814],0); -ELEMENTS[68010] = Fluid3D([18576,18558,18438,18486],0); -ELEMENTS[68011] = Fluid3D([14003,14403,13964,13484],0); -ELEMENTS[68012] = Fluid3D([14405,13640,14113,13728],0); -ELEMENTS[68013] = Fluid3D([15468,14843,15191,15820],0); -ELEMENTS[68014] = Fluid3D([13409,13090,13931,14385],0); -ELEMENTS[68015] = Fluid3D([9404,8576,9325,10374],0); -ELEMENTS[68016] = Fluid3D([14983,15249,15799,15607],0); -ELEMENTS[68017] = Fluid3D([4744,5098,4634,4476],0); -ELEMENTS[68018] = Fluid3D([14659,15235,15040,15397],0); -ELEMENTS[68019] = Fluid3D([10576,11086,11962,11059],0); -ELEMENTS[68020] = Fluid3D([3830,4172,4100,3591],0); -ELEMENTS[68021] = Fluid3D([11794,11254,11327,10856],0); -ELEMENTS[68022] = Fluid3D([13753,13125,12878,13954],0); -ELEMENTS[68023] = Fluid3D([12151,12574,12115,11455],0); -ELEMENTS[68024] = Fluid3D([15707,15485,15962,15506],0); -ELEMENTS[68025] = Fluid3D([12522,11704,12783,12161],0); -ELEMENTS[68026] = Fluid3D([14916,15530,14811,15616],0); -ELEMENTS[68027] = Fluid3D([16980,16780,16870,17282],0); -ELEMENTS[68028] = Fluid3D([12684,12807,11999,12343],0); -ELEMENTS[68029] = Fluid3D([16014,16200,16453,15731],0); -ELEMENTS[68030] = Fluid3D([13067,14045,13330,12970],0); -ELEMENTS[68031] = Fluid3D([7497,8097,8347,7249],0); -ELEMENTS[68032] = Fluid3D([8347,7497,7249,7740],0); -ELEMENTS[68033] = Fluid3D([8347,7497,7740,8877],0); -ELEMENTS[68034] = Fluid3D([6856,6806,7432,7613],0); -ELEMENTS[68035] = Fluid3D([6856,6806,7613,6332],0); -ELEMENTS[68036] = Fluid3D([15671,16037,16413,16230],0); -ELEMENTS[68037] = Fluid3D([14781,14545,13704,14373],0); -ELEMENTS[68038] = Fluid3D([14781,14545,14373,15140],0); -ELEMENTS[68039] = Fluid3D([14781,14545,15140,15297],0); -ELEMENTS[68040] = Fluid3D([14781,14545,15297,15025],0); -ELEMENTS[68041] = Fluid3D([10282,11416,11593,10514],0); -ELEMENTS[68042] = Fluid3D([4344,4669,5109,4693],0); -ELEMENTS[68043] = Fluid3D([4344,4669,4693,4150],0); -ELEMENTS[68044] = Fluid3D([4693,4344,4150,4220],0); -ELEMENTS[68045] = Fluid3D([4344,4150,4220,3950],0); -ELEMENTS[68046] = Fluid3D([4344,4150,3950,4669],0); -ELEMENTS[68047] = Fluid3D([7133,6779,6192,6860],0); -ELEMENTS[68048] = Fluid3D([15852,15740,15674,15036],0); -ELEMENTS[68049] = Fluid3D([15740,15674,15036,14974],0); -ELEMENTS[68050] = Fluid3D([15036,15740,14974,15432],0); -ELEMENTS[68051] = Fluid3D([6220,6802,6093,5947],0); -ELEMENTS[68052] = Fluid3D([2781,2988,3020,3239],0); -ELEMENTS[68053] = Fluid3D([2567,2751,2556,2317],0); -ELEMENTS[68054] = Fluid3D([7520,7482,8341,8056],0); -ELEMENTS[68055] = Fluid3D([6286,6611,5828,6568],0); -ELEMENTS[68056] = Fluid3D([7794,7543,8649,7880],0); -ELEMENTS[68057] = Fluid3D([8911,9415,8912,8414],0); -ELEMENTS[68058] = Fluid3D([8912,8911,8414,8722],0); -ELEMENTS[68059] = Fluid3D([18623,18608,18662,18666],0); -ELEMENTS[68060] = Fluid3D([9634,10603,10718,10515],0); -ELEMENTS[68061] = Fluid3D([15290,14754,15297,15393],0); -ELEMENTS[68062] = Fluid3D([3807,3421,3590,3829],0); -ELEMENTS[68063] = Fluid3D([15701,15357,16025,16131],0); -ELEMENTS[68064] = Fluid3D([1919,1897,2075,1989],0); -ELEMENTS[68065] = Fluid3D([13138,12575,12967,13918],0); -ELEMENTS[68066] = Fluid3D([4609,4066,4410,4250],0); -ELEMENTS[68067] = Fluid3D([18280,18315,18244,18008],0); -ELEMENTS[68068] = Fluid3D([1783,1705,1606,1706],0); -ELEMENTS[68069] = Fluid3D([13703,14301,13907,13839],0); -ELEMENTS[68070] = Fluid3D([17667,17629,17927,18032],0); -ELEMENTS[68071] = Fluid3D([11317,11764,11241,10861],0); -ELEMENTS[68072] = Fluid3D([15761,15402,15416,15805],0); -ELEMENTS[68073] = Fluid3D([9809,10601,9850,10699],0); -ELEMENTS[68074] = Fluid3D([12900,12214,12921,13097],0); -ELEMENTS[68075] = Fluid3D([2772,3094,3073,2945],0); -ELEMENTS[68076] = Fluid3D([3073,2772,2945,2725],0); -ELEMENTS[68077] = Fluid3D([12620,11616,12286,11526],0); -ELEMENTS[68078] = Fluid3D([15419,15001,14661,14793],0); -ELEMENTS[68079] = Fluid3D([7762,8710,8623,8426],0); -ELEMENTS[68080] = Fluid3D([5313,4719,4890,4963],0); -ELEMENTS[68081] = Fluid3D([12615,12995,12979,12237],0); -ELEMENTS[68082] = Fluid3D([13780,14231,14268,14906],0); -ELEMENTS[68083] = Fluid3D([14571,15225,15406,15059],0); -ELEMENTS[68084] = Fluid3D([16124,16382,16477,15765],0); -ELEMENTS[68085] = Fluid3D([12444,12704,13402,13525],0); -ELEMENTS[68086] = Fluid3D([4888,4825,4886,5548],0); -ELEMENTS[68087] = Fluid3D([15557,15357,15139,16131],0); -ELEMENTS[68088] = Fluid3D([15557,15357,16131,16317],0); -ELEMENTS[68089] = Fluid3D([7250,6953,7472,6302],0); -ELEMENTS[68090] = Fluid3D([3641,3447,3138,3478],0); -ELEMENTS[68091] = Fluid3D([17708,17921,17647,17846],0); -ELEMENTS[68092] = Fluid3D([16252,16768,16776,16674],0); -ELEMENTS[68093] = Fluid3D([13553,13527,14168,13336],0); -ELEMENTS[68094] = Fluid3D([17063,16686,17057,17272],0); -ELEMENTS[68095] = Fluid3D([12301,12473,12448,13475],0); -ELEMENTS[68096] = Fluid3D([4326,4359,4639,3826],0); -ELEMENTS[68097] = Fluid3D([9692,9683,9325,8576],0); -ELEMENTS[68098] = Fluid3D([9091,8934,9011,7983],0); -ELEMENTS[68099] = Fluid3D([16541,16105,16313,16454],0); -ELEMENTS[68100] = Fluid3D([10831,11474,12016,11423],0); -ELEMENTS[68101] = Fluid3D([2485,2724,2652,2483],0); -ELEMENTS[68102] = Fluid3D([2485,2724,2483,2805],0); -ELEMENTS[68103] = Fluid3D([2724,2483,2805,2652],0); -ELEMENTS[68104] = Fluid3D([13405,13821,14412,14100],0); -ELEMENTS[68105] = Fluid3D([13405,13821,14100,12973],0); -ELEMENTS[68106] = Fluid3D([13853,13523,13945,13151],0); -ELEMENTS[68107] = Fluid3D([5634,5641,5406,4958],0); -ELEMENTS[68108] = Fluid3D([10131,10194,11064,11073],0); -ELEMENTS[68109] = Fluid3D([12830,13032,12893,13621],0); -ELEMENTS[68110] = Fluid3D([12934,12414,12808,12246],0); -ELEMENTS[68111] = Fluid3D([9459,9379,9957,10240],0); -ELEMENTS[68112] = Fluid3D([9957,9459,10240,9785],0); -ELEMENTS[68113] = Fluid3D([15230,15091,14891,14182],0); -ELEMENTS[68114] = Fluid3D([11786,11146,11969,10571],0); -ELEMENTS[68115] = Fluid3D([16570,16385,15899,15944],0); -ELEMENTS[68116] = Fluid3D([7424,7622,8029,8318],0); -ELEMENTS[68117] = Fluid3D([7785,7406,6722,6614],0); -ELEMENTS[68118] = Fluid3D([2825,2649,2509,2988],0); -ELEMENTS[68119] = Fluid3D([14099,13697,14584,13566],0); -ELEMENTS[68120] = Fluid3D([14099,13697,13566,13438],0); -ELEMENTS[68121] = Fluid3D([12887,13429,13321,13679],0); -ELEMENTS[68122] = Fluid3D([9950,10824,9604,10573],0); -ELEMENTS[68123] = Fluid3D([3041,2988,3050,2649],0); -ELEMENTS[68124] = Fluid3D([4926,4756,4840,5572],0); -ELEMENTS[68125] = Fluid3D([5628,5940,6227,6458],0); -ELEMENTS[68126] = Fluid3D([2460,2403,2314,2237],0); -ELEMENTS[68127] = Fluid3D([2314,2460,2237,2204],0); -ELEMENTS[68128] = Fluid3D([9628,10769,9931,10414],0); -ELEMENTS[68129] = Fluid3D([4150,3562,3765,3778],0); -ELEMENTS[68130] = Fluid3D([15376,14937,14936,14439],0); -ELEMENTS[68131] = Fluid3D([15376,14937,14439,15182],0); -ELEMENTS[68132] = Fluid3D([17004,17297,17292,17691],0); -ELEMENTS[68133] = Fluid3D([18649,18608,18662,18643],0); -ELEMENTS[68134] = Fluid3D([17041,16944,16999,17348],0); -ELEMENTS[68135] = Fluid3D([16944,16999,17348,16782],0); -ELEMENTS[68136] = Fluid3D([3195,3239,2866,2781],0); -ELEMENTS[68137] = Fluid3D([3608,3837,3433,3933],0); -ELEMENTS[68138] = Fluid3D([3433,3608,3933,4118],0); -ELEMENTS[68139] = Fluid3D([3608,3837,3933,3852],0); -ELEMENTS[68140] = Fluid3D([18221,18171,18323,18142],0); -ELEMENTS[68141] = Fluid3D([15172,14829,15626,15041],0); -ELEMENTS[68142] = Fluid3D([9316,9584,8859,9274],0); -ELEMENTS[68143] = Fluid3D([11417,10319,10797,11023],0); -ELEMENTS[68144] = Fluid3D([12260,12813,13034,12128],0); -ELEMENTS[68145] = Fluid3D([13034,12260,12128,12468],0); -ELEMENTS[68146] = Fluid3D([7096,7510,7850,7776],0); -ELEMENTS[68147] = Fluid3D([14713,15282,15116,15463],0); -ELEMENTS[68148] = Fluid3D([16603,16115,16444,16763],0); -ELEMENTS[68149] = Fluid3D([8818,7922,8897,8208],0); -ELEMENTS[68150] = Fluid3D([7922,8897,8208,7616],0); -ELEMENTS[68151] = Fluid3D([4941,4617,4413,4946],0); -ELEMENTS[68152] = Fluid3D([17984,17894,17945,17612],0); -ELEMENTS[68153] = Fluid3D([17894,17945,17612,18017],0); -ELEMENTS[68154] = Fluid3D([17945,17984,17612,17651],0); -ELEMENTS[68155] = Fluid3D([5511,5687,5784,5064],0); -ELEMENTS[68156] = Fluid3D([17075,16932,17194,17386],0); -ELEMENTS[68157] = Fluid3D([18310,18412,18378,18421],0); -ELEMENTS[68158] = Fluid3D([6456,6965,6891,6091],0); -ELEMENTS[68159] = Fluid3D([11412,10967,12179,12175],0); -ELEMENTS[68160] = Fluid3D([7115,6935,6954,7916],0); -ELEMENTS[68161] = Fluid3D([15218,14977,14947,15303],0); -ELEMENTS[68162] = Fluid3D([17241,17474,17695,17623],0); -ELEMENTS[68163] = Fluid3D([8849,9607,8634,9902],0); -ELEMENTS[68164] = Fluid3D([14338,13693,14275,13518],0); -ELEMENTS[68165] = Fluid3D([17189,17510,17566,17100],0); -ELEMENTS[68166] = Fluid3D([12815,12148,13461,12875],0); -ELEMENTS[68167] = Fluid3D([13461,12815,12875,12866],0); -ELEMENTS[68168] = Fluid3D([8089,7360,8042,8794],0); -ELEMENTS[68169] = Fluid3D([13518,13721,13863,14262],0); -ELEMENTS[68170] = Fluid3D([11277,10488,11285,10905],0); -ELEMENTS[68171] = Fluid3D([10488,11285,10905,10186],0); -ELEMENTS[68172] = Fluid3D([10905,10488,10186,11277],0); -ELEMENTS[68173] = Fluid3D([11285,10905,10186,10386],0); -ELEMENTS[68174] = Fluid3D([10905,10186,10386,10782],0); -ELEMENTS[68175] = Fluid3D([17676,17495,17834,17378],0); -ELEMENTS[68176] = Fluid3D([5924,5408,5486,5397],0); -ELEMENTS[68177] = Fluid3D([18550,18597,18646,18526],0); -ELEMENTS[68178] = Fluid3D([18550,18597,18526,18421],0); -ELEMENTS[68179] = Fluid3D([6110,5976,5791,5400],0); -ELEMENTS[68180] = Fluid3D([16686,16259,16851,16448],0); -ELEMENTS[68181] = Fluid3D([7126,6450,6708,6073],0); -ELEMENTS[68182] = Fluid3D([16536,16072,16730,16453],0); -ELEMENTS[68183] = Fluid3D([18549,18638,18615,18520],0); -ELEMENTS[68184] = Fluid3D([17958,17909,18102,18224],0); -ELEMENTS[68185] = Fluid3D([17958,17909,18224,18264],0); -ELEMENTS[68186] = Fluid3D([8021,7217,7154,7554],0); -ELEMENTS[68187] = Fluid3D([7195,7677,6836,7722],0); -ELEMENTS[68188] = Fluid3D([14783,14824,15531,14957],0); -ELEMENTS[68189] = Fluid3D([7713,7491,6862,6893],0); -ELEMENTS[68190] = Fluid3D([15370,14652,14363,14890],0); -ELEMENTS[68191] = Fluid3D([15120,15778,15791,15872],0); -ELEMENTS[68192] = Fluid3D([15778,15791,15872,16434],0); -ELEMENTS[68193] = Fluid3D([6615,7465,6984,6868],0); -ELEMENTS[68194] = Fluid3D([4733,4404,4339,5234],0); -ELEMENTS[68195] = Fluid3D([8976,8784,9828,9421],0); -ELEMENTS[68196] = Fluid3D([15673,15906,15049,15305],0); -ELEMENTS[68197] = Fluid3D([15321,15035,14933,14854],0); -ELEMENTS[68198] = Fluid3D([14933,15321,14854,15658],0); -ELEMENTS[68199] = Fluid3D([10382,9314,10430,9966],0); -ELEMENTS[68200] = Fluid3D([10430,10382,9966,11316],0); -ELEMENTS[68201] = Fluid3D([17622,17267,17616,17221],0); -ELEMENTS[68202] = Fluid3D([12530,11637,11913,12053],0); -ELEMENTS[68203] = Fluid3D([17088,17197,16678,17167],0); -ELEMENTS[68204] = Fluid3D([2794,2638,2913,2527],0); -ELEMENTS[68205] = Fluid3D([12423,12627,13282,13660],0); -ELEMENTS[68206] = Fluid3D([17194,16555,17081,16932],0); -ELEMENTS[68207] = Fluid3D([16555,17081,16932,16799],0); -ELEMENTS[68208] = Fluid3D([1987,1916,2118,1910],0); -ELEMENTS[68209] = Fluid3D([2753,2891,3011,2660],0); -ELEMENTS[68210] = Fluid3D([17200,16606,17034,16981],0); -ELEMENTS[68211] = Fluid3D([5088,4765,5612,5409],0); -ELEMENTS[68212] = Fluid3D([9913,9744,9396,10708],0); -ELEMENTS[68213] = Fluid3D([5761,6447,6253,5805],0); -ELEMENTS[68214] = Fluid3D([6253,5761,5805,5295],0); -ELEMENTS[68215] = Fluid3D([6447,6253,5805,6575],0); -ELEMENTS[68216] = Fluid3D([5761,6447,5805,5476],0); -ELEMENTS[68217] = Fluid3D([12407,12012,12044,11675],0); -ELEMENTS[68218] = Fluid3D([12407,12012,11675,11632],0); -ELEMENTS[68219] = Fluid3D([12012,11675,11632,10770],0); -ELEMENTS[68220] = Fluid3D([11675,11632,10770,10803],0); -ELEMENTS[68221] = Fluid3D([11675,11632,10803,11995],0); -ELEMENTS[68222] = Fluid3D([11675,12407,11632,12684],0); -ELEMENTS[68223] = Fluid3D([6715,6467,6348,7122],0); -ELEMENTS[68224] = Fluid3D([6715,6467,7122,7771],0); -ELEMENTS[68225] = Fluid3D([16342,16581,16449,16915],0); -ELEMENTS[68226] = Fluid3D([12851,11890,12823,12764],0); -ELEMENTS[68227] = Fluid3D([12823,12851,12764,13977],0); -ELEMENTS[68228] = Fluid3D([1829,1976,1849,1966],0); -ELEMENTS[68229] = Fluid3D([4820,5328,5112,4816],0); -ELEMENTS[68230] = Fluid3D([18138,18316,18424,18298],0); -ELEMENTS[68231] = Fluid3D([17860,17704,17554,17720],0); -ELEMENTS[68232] = Fluid3D([17704,17554,17720,17317],0); -ELEMENTS[68233] = Fluid3D([17860,17704,17720,18004],0); -ELEMENTS[68234] = Fluid3D([15205,15136,14741,15378],0); -ELEMENTS[68235] = Fluid3D([15722,15162,15852,15828],0); -ELEMENTS[68236] = Fluid3D([4711,4243,4821,4407],0); -ELEMENTS[68237] = Fluid3D([17314,17679,17757,17274],0); -ELEMENTS[68238] = Fluid3D([5959,6143,5895,5338],0); -ELEMENTS[68239] = Fluid3D([12205,12851,12236,11708],0); -ELEMENTS[68240] = Fluid3D([11249,11855,11420,12150],0); -ELEMENTS[68241] = Fluid3D([3815,4274,4222,4460],0); -ELEMENTS[68242] = Fluid3D([4274,4222,4460,4912],0); -ELEMENTS[68243] = Fluid3D([15767,15097,14849,15353],0); -ELEMENTS[68244] = Fluid3D([3418,3721,3598,4030],0); -ELEMENTS[68245] = Fluid3D([17468,17339,17105,17517],0); -ELEMENTS[68246] = Fluid3D([17468,17339,17517,17754],0); -ELEMENTS[68247] = Fluid3D([17517,17468,17754,17819],0); -ELEMENTS[68248] = Fluid3D([17517,17468,17819,17301],0); -ELEMENTS[68249] = Fluid3D([17517,17468,17301,17105],0); -ELEMENTS[68250] = Fluid3D([17754,17517,17819,17907],0); -ELEMENTS[68251] = Fluid3D([5711,5443,5369,4851],0); -ELEMENTS[68252] = Fluid3D([9361,10114,9633,8852],0); -ELEMENTS[68253] = Fluid3D([10351,10199,9940,10796],0); -ELEMENTS[68254] = Fluid3D([2775,2639,2996,3053],0); -ELEMENTS[68255] = Fluid3D([5941,5824,5461,5164],0); -ELEMENTS[68256] = Fluid3D([13925,14284,14410,13334],0); -ELEMENTS[68257] = Fluid3D([18350,18292,18435,18340],0); -ELEMENTS[68258] = Fluid3D([4663,4628,5081,4946],0); -ELEMENTS[68259] = Fluid3D([8829,8727,7733,7661],0); -ELEMENTS[68260] = Fluid3D([14516,14869,13989,13775],0); -ELEMENTS[68261] = Fluid3D([13458,14002,14235,13843],0); -ELEMENTS[68262] = Fluid3D([10249,9959,9265,8820],0); -ELEMENTS[68263] = Fluid3D([7784,6997,8066,7737],0); -ELEMENTS[68264] = Fluid3D([8066,7784,7737,9179],0); -ELEMENTS[68265] = Fluid3D([7784,6997,7737,6899],0); -ELEMENTS[68266] = Fluid3D([7737,7784,6899,8090],0); -ELEMENTS[68267] = Fluid3D([7737,7784,8090,9179],0); -ELEMENTS[68268] = Fluid3D([2057,2167,2179,1955],0); -ELEMENTS[68269] = Fluid3D([13709,13986,12772,13394],0); -ELEMENTS[68270] = Fluid3D([13709,13986,13394,14050],0); -ELEMENTS[68271] = Fluid3D([17140,17186,17574,17452],0); -ELEMENTS[68272] = Fluid3D([17590,17564,17889,17575],0); -ELEMENTS[68273] = Fluid3D([11989,11029,11004,12063],0); -ELEMENTS[68274] = Fluid3D([4870,5031,5524,5370],0); -ELEMENTS[68275] = Fluid3D([4870,5031,5370,5311],0); -ELEMENTS[68276] = Fluid3D([5031,5370,5311,5524],0); -ELEMENTS[68277] = Fluid3D([12327,13393,12719,13144],0); -ELEMENTS[68278] = Fluid3D([11781,12023,11004,10815],0); -ELEMENTS[68279] = Fluid3D([18079,17834,17710,17940],0); -ELEMENTS[68280] = Fluid3D([18079,17834,17940,18150],0); -ELEMENTS[68281] = Fluid3D([14868,14867,15127,14255],0); -ELEMENTS[68282] = Fluid3D([14867,15127,14255,14799],0); -ELEMENTS[68283] = Fluid3D([12237,11728,11656,12438],0); -ELEMENTS[68284] = Fluid3D([8021,7258,7860,7154],0); -ELEMENTS[68285] = Fluid3D([3609,4089,4169,3986],0); -ELEMENTS[68286] = Fluid3D([16717,17057,16613,16686],0); -ELEMENTS[68287] = Fluid3D([4487,4825,4944,5288],0); -ELEMENTS[68288] = Fluid3D([16535,16221,15986,16705],0); -ELEMENTS[68289] = Fluid3D([17679,17847,17585,17277],0); -ELEMENTS[68290] = Fluid3D([15480,15816,16346,16300],0); -ELEMENTS[68291] = Fluid3D([11548,12082,12450,12894],0); -ELEMENTS[68292] = Fluid3D([16939,16586,16498,16132],0); -ELEMENTS[68293] = Fluid3D([1807,1972,1959,1756],0); -ELEMENTS[68294] = Fluid3D([7252,7387,8340,7676],0); -ELEMENTS[68295] = Fluid3D([16438,16002,16623,16825],0); -ELEMENTS[68296] = Fluid3D([16623,16438,16825,16865],0); -ELEMENTS[68297] = Fluid3D([16438,16825,16865,16425],0); -ELEMENTS[68298] = Fluid3D([10240,10978,10258,9544],0); -ELEMENTS[68299] = Fluid3D([10258,10240,9544,9785],0); -ELEMENTS[68300] = Fluid3D([18433,18418,18169,18335],0); -ELEMENTS[68301] = Fluid3D([13041,12351,13040,12275],0); -ELEMENTS[68302] = Fluid3D([8085,7237,8551,7673],0); -ELEMENTS[68303] = Fluid3D([14983,14720,15607,15375],0); -ELEMENTS[68304] = Fluid3D([11775,11182,11605,11900],0); -ELEMENTS[68305] = Fluid3D([4386,4861,4800,5158],0); -ELEMENTS[68306] = Fluid3D([10881,11706,10958,10102],0); -ELEMENTS[68307] = Fluid3D([13580,13073,12511,12541],0); -ELEMENTS[68308] = Fluid3D([10561,10381,10313,11392],0); -ELEMENTS[68309] = Fluid3D([10561,10381,11392,11203],0); -ELEMENTS[68310] = Fluid3D([13955,13548,14391,14528],0); -ELEMENTS[68311] = Fluid3D([8817,9593,9500,9854],0); -ELEMENTS[68312] = Fluid3D([15604,15714,16124,16145],0); -ELEMENTS[68313] = Fluid3D([6029,5702,6420,5920],0); -ELEMENTS[68314] = Fluid3D([9999,9440,10546,9702],0); -ELEMENTS[68315] = Fluid3D([3954,3797,3805,3890],0); -ELEMENTS[68316] = Fluid3D([4641,4768,4110,4700],0); -ELEMENTS[68317] = Fluid3D([18380,18333,18210,18060],0); -ELEMENTS[68318] = Fluid3D([3826,4107,3699,3676],0); -ELEMENTS[68319] = Fluid3D([11591,10807,12014,11447],0); -ELEMENTS[68320] = Fluid3D([8569,9259,8270,8722],0); -ELEMENTS[68321] = Fluid3D([8270,8569,8722,7893],0); -ELEMENTS[68322] = Fluid3D([2595,2886,3013,2944],0); -ELEMENTS[68323] = Fluid3D([2886,3013,2944,3267],0); -ELEMENTS[68324] = Fluid3D([5055,4664,4454,5141],0); -ELEMENTS[68325] = Fluid3D([3023,3298,3403,3574],0); -ELEMENTS[68326] = Fluid3D([13187,13996,13907,13058],0); -ELEMENTS[68327] = Fluid3D([15110,15317,15141,15715],0); -ELEMENTS[68328] = Fluid3D([3655,3401,3367,3383],0); -ELEMENTS[68329] = Fluid3D([14021,14521,14374,14913],0); -ELEMENTS[68330] = Fluid3D([6232,6612,6967,7484],0); -ELEMENTS[68331] = Fluid3D([11082,11162,10206,10706],0); -ELEMENTS[68332] = Fluid3D([11082,11162,10706,11367],0); -ELEMENTS[68333] = Fluid3D([10706,11082,11367,9899],0); -ELEMENTS[68334] = Fluid3D([11082,11162,11367,12209],0); -ELEMENTS[68335] = Fluid3D([3643,3336,3704,4032],0); -ELEMENTS[68336] = Fluid3D([3704,3643,4032,4049],0); -ELEMENTS[68337] = Fluid3D([4032,3704,4049,4159],0); -ELEMENTS[68338] = Fluid3D([3704,3643,4049,3913],0); -ELEMENTS[68339] = Fluid3D([4049,3704,3913,4159],0); -ELEMENTS[68340] = Fluid3D([3913,4049,4159,4506],0); -ELEMENTS[68341] = Fluid3D([3913,4049,4506,4286],0); -ELEMENTS[68342] = Fluid3D([3643,4049,3913,4286],0); -ELEMENTS[68343] = Fluid3D([11702,12403,12845,12619],0); -ELEMENTS[68344] = Fluid3D([17904,17978,17875,18111],0); -ELEMENTS[68345] = Fluid3D([17978,17875,18111,18276],0); -ELEMENTS[68346] = Fluid3D([18111,17978,18276,18264],0); -ELEMENTS[68347] = Fluid3D([18276,18111,18264,18130],0); -ELEMENTS[68348] = Fluid3D([17904,17978,18111,18264],0); -ELEMENTS[68349] = Fluid3D([17875,18111,18276,18200],0); -ELEMENTS[68350] = Fluid3D([18111,18276,18200,18098],0); -ELEMENTS[68351] = Fluid3D([18111,18276,18098,18287],0); -ELEMENTS[68352] = Fluid3D([18098,18111,18287,18130],0); -ELEMENTS[68353] = Fluid3D([18200,18111,18098,17875],0); -ELEMENTS[68354] = Fluid3D([18111,18098,17875,17731],0); -ELEMENTS[68355] = Fluid3D([18111,18276,18287,18130],0); -ELEMENTS[68356] = Fluid3D([16414,15977,16280,16445],0); -ELEMENTS[68357] = Fluid3D([6228,6979,7161,6521],0); -ELEMENTS[68358] = Fluid3D([7591,7808,7848,8178],0); -ELEMENTS[68359] = Fluid3D([11962,12271,11260,11612],0); -ELEMENTS[68360] = Fluid3D([11383,10436,11171,11189],0); -ELEMENTS[68361] = Fluid3D([9703,10289,9375,9554],0); -ELEMENTS[68362] = Fluid3D([9703,10289,9554,10795],0); -ELEMENTS[68363] = Fluid3D([8549,8880,7818,7934],0); -ELEMENTS[68364] = Fluid3D([18028,17709,17797,17595],0); -ELEMENTS[68365] = Fluid3D([9513,8750,9481,8850],0); -ELEMENTS[68366] = Fluid3D([4369,4446,3890,4521],0); -ELEMENTS[68367] = Fluid3D([3877,4423,4054,3970],0); -ELEMENTS[68368] = Fluid3D([17765,17883,18002,17649],0); -ELEMENTS[68369] = Fluid3D([16610,16309,16645,16736],0); -ELEMENTS[68370] = Fluid3D([12734,12700,12241,11853],0); -ELEMENTS[68371] = Fluid3D([9209,9176,9734,10182],0); -ELEMENTS[68372] = Fluid3D([2804,2701,3036,2743],0); -ELEMENTS[68373] = Fluid3D([2701,3036,2743,2828],0); -ELEMENTS[68374] = Fluid3D([17528,17228,17017,17097],0); -ELEMENTS[68375] = Fluid3D([5661,5021,5574,4898],0); -ELEMENTS[68376] = Fluid3D([15550,15616,15033,15145],0); -ELEMENTS[68377] = Fluid3D([7199,7952,7981,7775],0); -ELEMENTS[68378] = Fluid3D([8594,9638,8969,8829],0); -ELEMENTS[68379] = Fluid3D([8969,8594,8829,8297],0); -ELEMENTS[68380] = Fluid3D([8829,8969,8297,9402],0); -ELEMENTS[68381] = Fluid3D([8297,8829,9402,8708],0); -ELEMENTS[68382] = Fluid3D([16110,16063,16366,16821],0); -ELEMENTS[68383] = Fluid3D([11333,11795,10339,11298],0); -ELEMENTS[68384] = Fluid3D([3949,4229,4345,4390],0); -ELEMENTS[68385] = Fluid3D([10705,10213,11542,11131],0); -ELEMENTS[68386] = Fluid3D([10705,10213,11131,10680],0); -ELEMENTS[68387] = Fluid3D([15709,15741,15466,15208],0); -ELEMENTS[68388] = Fluid3D([15741,15466,15208,15498],0); -ELEMENTS[68389] = Fluid3D([15466,15208,15498,15345],0); -ELEMENTS[68390] = Fluid3D([15498,15466,15345,16244],0); -ELEMENTS[68391] = Fluid3D([15466,15208,15345,14837],0); -ELEMENTS[68392] = Fluid3D([15466,15208,14837,15709],0); -ELEMENTS[68393] = Fluid3D([11616,10854,11231,11526],0); -ELEMENTS[68394] = Fluid3D([18367,18198,18476,18309],0); -ELEMENTS[68395] = Fluid3D([10849,11221,10126,11001],0); -ELEMENTS[68396] = Fluid3D([16294,15877,16426,15950],0); -ELEMENTS[68397] = Fluid3D([16426,16294,15950,16500],0); -ELEMENTS[68398] = Fluid3D([13485,12961,12943,13511],0); -ELEMENTS[68399] = Fluid3D([16554,16324,16769,16773],0); -ELEMENTS[68400] = Fluid3D([17021,16691,17085,16422],0); -ELEMENTS[68401] = Fluid3D([14993,15012,15102,14627],0); -ELEMENTS[68402] = Fluid3D([17542,17218,17487,17453],0); -ELEMENTS[68403] = Fluid3D([5295,4914,5223,5537],0); -ELEMENTS[68404] = Fluid3D([5175,5949,5393,5909],0); -ELEMENTS[68405] = Fluid3D([11321,11950,11386,12675],0); -ELEMENTS[68406] = Fluid3D([3460,3154,3193,3012],0); -ELEMENTS[68407] = Fluid3D([13396,13823,13952,13828],0); -ELEMENTS[68408] = Fluid3D([4561,4909,4339,4375],0); -ELEMENTS[68409] = Fluid3D([7132,7491,7509,6461],0); -ELEMENTS[68410] = Fluid3D([10346,10767,9702,9888],0); -ELEMENTS[68411] = Fluid3D([6744,6100,6709,6138],0); -ELEMENTS[68412] = Fluid3D([10875,11045,10134,10695],0); -ELEMENTS[68413] = Fluid3D([7627,8089,7652,6894],0); -ELEMENTS[68414] = Fluid3D([8891,8615,8488,7614],0); -ELEMENTS[68415] = Fluid3D([10924,11238,11009,10205],0); -ELEMENTS[68416] = Fluid3D([5005,4968,5489,5038],0); -ELEMENTS[68417] = Fluid3D([5005,4968,5038,4385],0); -ELEMENTS[68418] = Fluid3D([2742,2555,2905,2512],0); -ELEMENTS[68419] = Fluid3D([12297,12048,13017,12280],0); -ELEMENTS[68420] = Fluid3D([16640,17135,16678,17167],0); -ELEMENTS[68421] = Fluid3D([11771,11158,10605,11921],0); -ELEMENTS[68422] = Fluid3D([14419,14204,14702,13746],0); -ELEMENTS[68423] = Fluid3D([7065,7746,7701,7089],0); -ELEMENTS[68424] = Fluid3D([10633,9954,10893,11152],0); -ELEMENTS[68425] = Fluid3D([16578,16332,16075,15851],0); -ELEMENTS[68426] = Fluid3D([8886,8720,9954,10006],0); -ELEMENTS[68427] = Fluid3D([16113,15957,15428,16012],0); -ELEMENTS[68428] = Fluid3D([15957,15428,16012,15686],0); -ELEMENTS[68429] = Fluid3D([16113,15957,16012,16700],0); -ELEMENTS[68430] = Fluid3D([16012,15957,15686,16057],0); -ELEMENTS[68431] = Fluid3D([15428,16012,15686,15519],0); -ELEMENTS[68432] = Fluid3D([15428,16012,15519,16113],0); -ELEMENTS[68433] = Fluid3D([15686,16012,16057,16430],0); -ELEMENTS[68434] = Fluid3D([15686,16012,16430,16242],0); -ELEMENTS[68435] = Fluid3D([16012,16430,16242,16417],0); -ELEMENTS[68436] = Fluid3D([16012,16430,16417,16700],0); -ELEMENTS[68437] = Fluid3D([16242,16012,16417,16113],0); -ELEMENTS[68438] = Fluid3D([16012,16430,16700,16057],0); -ELEMENTS[68439] = Fluid3D([16012,16417,16113,16700],0); -ELEMENTS[68440] = Fluid3D([16430,16417,16700,16688],0); -ELEMENTS[68441] = Fluid3D([16430,16242,16417,16688],0); -ELEMENTS[68442] = Fluid3D([16242,16417,16688,16113],0); -ELEMENTS[68443] = Fluid3D([16417,16688,16113,16587],0); -ELEMENTS[68444] = Fluid3D([16417,16688,16587,16700],0); -ELEMENTS[68445] = Fluid3D([16113,16417,16587,16700],0); -ELEMENTS[68446] = Fluid3D([16688,16113,16587,16881],0); -ELEMENTS[68447] = Fluid3D([16587,16688,16881,16700],0); -ELEMENTS[68448] = Fluid3D([16881,16587,16700,16356],0); -ELEMENTS[68449] = Fluid3D([16881,16587,16356,16113],0); -ELEMENTS[68450] = Fluid3D([16587,16356,16113,16700],0); -ELEMENTS[68451] = Fluid3D([15686,16012,16242,15519],0); -ELEMENTS[68452] = Fluid3D([16012,16242,15519,16113],0); -ELEMENTS[68453] = Fluid3D([16430,16700,16057,16666],0); -ELEMENTS[68454] = Fluid3D([16430,16700,16666,16660],0); -ELEMENTS[68455] = Fluid3D([16430,16700,16660,17016],0); -ELEMENTS[68456] = Fluid3D([16430,16700,17016,16688],0); -ELEMENTS[68457] = Fluid3D([2763,3049,2710,2962],0); -ELEMENTS[68458] = Fluid3D([6126,6300,6320,5811],0); -ELEMENTS[68459] = Fluid3D([3799,4159,3497,3473],0); -ELEMENTS[68460] = Fluid3D([13584,14543,13265,14043],0); -ELEMENTS[68461] = Fluid3D([1795,1698,1811,1809],0); -ELEMENTS[68462] = Fluid3D([14315,14616,14286,13720],0); -ELEMENTS[68463] = Fluid3D([15459,15847,15473,15163],0); -ELEMENTS[68464] = Fluid3D([11832,12472,11908,11709],0); -ELEMENTS[68465] = Fluid3D([14705,14464,14731,15194],0); -ELEMENTS[68466] = Fluid3D([10789,11534,10116,10520],0); -ELEMENTS[68467] = Fluid3D([3776,3927,3526,3362],0); -ELEMENTS[68468] = Fluid3D([12981,12129,12745,12027],0); -ELEMENTS[68469] = Fluid3D([10651,9545,9285,10470],0); -ELEMENTS[68470] = Fluid3D([10651,9545,10470,9898],0); -ELEMENTS[68471] = Fluid3D([9545,10470,9898,9208],0); -ELEMENTS[68472] = Fluid3D([10470,10651,9898,11537],0); -ELEMENTS[68473] = Fluid3D([5282,5125,4741,4478],0); -ELEMENTS[68474] = Fluid3D([18522,18524,18609,18533],0); -ELEMENTS[68475] = Fluid3D([6813,6919,6980,7769],0); -ELEMENTS[68476] = Fluid3D([18004,18190,17860,17925],0); -ELEMENTS[68477] = Fluid3D([5173,4682,4954,4780],0); -ELEMENTS[68478] = Fluid3D([16637,16427,16812,17115],0); -ELEMENTS[68479] = Fluid3D([10137,10702,11203,9892],0); -ELEMENTS[68480] = Fluid3D([18154,18279,18026,17947],0); -ELEMENTS[68481] = Fluid3D([4009,3542,3769,3484],0); -ELEMENTS[68482] = Fluid3D([3542,3769,3484,3299],0); -ELEMENTS[68483] = Fluid3D([18043,17905,18064,17775],0); -ELEMENTS[68484] = Fluid3D([8597,9242,8364,7969],0); -ELEMENTS[68485] = Fluid3D([9619,10066,11022,10414],0); -ELEMENTS[68486] = Fluid3D([4622,4437,3995,4112],0); -ELEMENTS[68487] = Fluid3D([4437,3995,4112,3966],0); -ELEMENTS[68488] = Fluid3D([18662,18637,18578,18583],0); -ELEMENTS[68489] = Fluid3D([17462,17243,17391,17008],0); -ELEMENTS[68490] = Fluid3D([3601,3253,3271,3578],0); -ELEMENTS[68491] = Fluid3D([3271,3601,3578,3809],0); -ELEMENTS[68492] = Fluid3D([3601,3253,3578,3765],0); -ELEMENTS[68493] = Fluid3D([3601,3578,3809,3958],0); -ELEMENTS[68494] = Fluid3D([3578,3809,3958,3576],0); -ELEMENTS[68495] = Fluid3D([3958,3578,3576,3458],0); -ELEMENTS[68496] = Fluid3D([3578,3576,3458,3140],0); -ELEMENTS[68497] = Fluid3D([3601,3578,3958,3765],0); -ELEMENTS[68498] = Fluid3D([3578,3958,3765,3458],0); -ELEMENTS[68499] = Fluid3D([3578,3809,3576,3271],0); -ELEMENTS[68500] = Fluid3D([3576,3578,3271,3140],0); -ELEMENTS[68501] = Fluid3D([3253,3271,3578,2955],0); -ELEMENTS[68502] = Fluid3D([3809,3601,3958,3983],0); -ELEMENTS[68503] = Fluid3D([5554,4916,5153,5043],0); -ELEMENTS[68504] = Fluid3D([13884,12928,12980,14106],0); -ELEMENTS[68505] = Fluid3D([15549,16065,15925,15784],0); -ELEMENTS[68506] = Fluid3D([15805,15955,15416,15761],0); -ELEMENTS[68507] = Fluid3D([13786,13398,12825,12959],0); -ELEMENTS[68508] = Fluid3D([12825,13786,12959,13278],0); -ELEMENTS[68509] = Fluid3D([13814,14309,14814,14252],0); -ELEMENTS[68510] = Fluid3D([11830,10709,11254,11206],0); -ELEMENTS[68511] = Fluid3D([12388,11945,11189,11703],0); -ELEMENTS[68512] = Fluid3D([9546,9616,10466,9792],0); -ELEMENTS[68513] = Fluid3D([10474,11473,10552,10638],0); -ELEMENTS[68514] = Fluid3D([4429,4025,4679,4745],0); -ELEMENTS[68515] = Fluid3D([8055,7520,7188,6936],0); -ELEMENTS[68516] = Fluid3D([14186,14293,14863,15134],0); -ELEMENTS[68517] = Fluid3D([4467,5053,4840,4637],0); -ELEMENTS[68518] = Fluid3D([17627,17740,17257,17753],0); -ELEMENTS[68519] = Fluid3D([3755,4083,3476,4007],0); -ELEMENTS[68520] = Fluid3D([3755,4083,4007,4134],0); -ELEMENTS[68521] = Fluid3D([14307,13865,13292,13726],0); -ELEMENTS[68522] = Fluid3D([11325,11316,10430,9966],0); -ELEMENTS[68523] = Fluid3D([4190,4071,3673,4023],0); -ELEMENTS[68524] = Fluid3D([11708,12050,12093,12694],0); -ELEMENTS[68525] = Fluid3D([4278,4896,4775,4241],0); -ELEMENTS[68526] = Fluid3D([16785,17206,16820,17020],0); -ELEMENTS[68527] = Fluid3D([2727,2594,2978,2948],0); -ELEMENTS[68528] = Fluid3D([16514,16579,16405,16035],0); -ELEMENTS[68529] = Fluid3D([2342,2507,2211,2254],0); -ELEMENTS[68530] = Fluid3D([5543,5622,5507,4965],0); -ELEMENTS[68531] = Fluid3D([5543,5622,4965,5669],0); -ELEMENTS[68532] = Fluid3D([15850,15223,15946,15892],0); -ELEMENTS[68533] = Fluid3D([7952,8610,7981,8295],0); -ELEMENTS[68534] = Fluid3D([7263,7074,8074,7781],0); -ELEMENTS[68535] = Fluid3D([13476,13759,12756,13741],0); -ELEMENTS[68536] = Fluid3D([6934,7315,6212,6838],0); -ELEMENTS[68537] = Fluid3D([3046,3032,3025,2637],0); -ELEMENTS[68538] = Fluid3D([7665,6887,6952,6618],0); -ELEMENTS[68539] = Fluid3D([10820,10531,11020,10528],0); -ELEMENTS[68540] = Fluid3D([18583,18472,18544,18591],0); -ELEMENTS[68541] = Fluid3D([18480,18513,18567,18510],0); -ELEMENTS[68542] = Fluid3D([16217,16510,16219,15735],0); -ELEMENTS[68543] = Fluid3D([10430,10236,11495,10988],0); -ELEMENTS[68544] = Fluid3D([11444,12196,12466,12519],0); -ELEMENTS[68545] = Fluid3D([5889,5585,5091,5787],0); -ELEMENTS[68546] = Fluid3D([3616,3403,3128,3049],0); -ELEMENTS[68547] = Fluid3D([9378,10205,10322,10848],0); -ELEMENTS[68548] = Fluid3D([17213,17567,17462,17270],0); -ELEMENTS[68549] = Fluid3D([17814,17761,17412,17450],0); -ELEMENTS[68550] = Fluid3D([16330,16162,15914,15767],0); -ELEMENTS[68551] = Fluid3D([8977,8587,9725,9226],0); -ELEMENTS[68552] = Fluid3D([14854,14742,14033,13822],0); -ELEMENTS[68553] = Fluid3D([8427,8362,9151,9467],0); -ELEMENTS[68554] = Fluid3D([6568,6828,5864,6286],0); -ELEMENTS[68555] = Fluid3D([9128,8204,9365,9220],0); -ELEMENTS[68556] = Fluid3D([6711,7087,6306,6251],0); -ELEMENTS[68557] = Fluid3D([6891,7050,6536,6091],0); -ELEMENTS[68558] = Fluid3D([4089,3631,4071,4205],0); -ELEMENTS[68559] = Fluid3D([9590,10465,9710,10362],0); -ELEMENTS[68560] = Fluid3D([18341,18229,18317,18318],0); -ELEMENTS[68561] = Fluid3D([6630,6193,5852,6757],0); -ELEMENTS[68562] = Fluid3D([6630,6193,6757,6710],0); -ELEMENTS[68563] = Fluid3D([6630,6193,6710,7023],0); -ELEMENTS[68564] = Fluid3D([6193,6710,7023,6234],0); -ELEMENTS[68565] = Fluid3D([6193,6757,6710,6601],0); -ELEMENTS[68566] = Fluid3D([6710,6193,6601,6090],0); -ELEMENTS[68567] = Fluid3D([6575,5993,5808,6619],0); -ELEMENTS[68568] = Fluid3D([1804,1875,1913,1818],0); -ELEMENTS[68569] = Fluid3D([1875,1913,1818,2087],0); -ELEMENTS[68570] = Fluid3D([1913,1804,1818,1879],0); -ELEMENTS[68571] = Fluid3D([1818,1913,1879,1931],0); -ELEMENTS[68572] = Fluid3D([1913,1818,2087,1931],0); -ELEMENTS[68573] = Fluid3D([16751,17056,16923,16780],0); -ELEMENTS[68574] = Fluid3D([5729,5529,5072,5282],0); -ELEMENTS[68575] = Fluid3D([12428,12245,11838,12481],0); -ELEMENTS[68576] = Fluid3D([16980,17319,17180,17164],0); -ELEMENTS[68577] = Fluid3D([11495,12083,12452,12968],0); -ELEMENTS[68578] = Fluid3D([17679,17751,17989,18066],0); -ELEMENTS[68579] = Fluid3D([3802,3740,4231,4069],0); -ELEMENTS[68580] = Fluid3D([6218,5675,5719,5490],0); -ELEMENTS[68581] = Fluid3D([16221,15626,15630,15651],0); -ELEMENTS[68582] = Fluid3D([16135,15822,15563,15281],0); -ELEMENTS[68583] = Fluid3D([5701,5212,5016,5458],0); -ELEMENTS[68584] = Fluid3D([13579,12924,13926,13307],0); -ELEMENTS[68585] = Fluid3D([18475,18601,18526,18550],0); -ELEMENTS[68586] = Fluid3D([14051,13732,14522,13275],0); -ELEMENTS[68587] = Fluid3D([5897,6641,5986,6366],0); -ELEMENTS[68588] = Fluid3D([14337,14775,15097,14564],0); -ELEMENTS[68589] = Fluid3D([10543,10232,9549,9192],0); -ELEMENTS[68590] = Fluid3D([9129,8910,9756,9520],0); -ELEMENTS[68591] = Fluid3D([9756,9129,9520,10232],0); -ELEMENTS[68592] = Fluid3D([8910,9756,9520,9549],0); -ELEMENTS[68593] = Fluid3D([9520,8910,9549,8946],0); -ELEMENTS[68594] = Fluid3D([9549,9520,8946,10232],0); -ELEMENTS[68595] = Fluid3D([9549,9520,10232,9756],0); -ELEMENTS[68596] = Fluid3D([9520,8946,10232,9129],0); -ELEMENTS[68597] = Fluid3D([9520,8946,9129,8910],0); -ELEMENTS[68598] = Fluid3D([9150,8814,9472,9075],0); -ELEMENTS[68599] = Fluid3D([8814,9472,9075,8259],0); -ELEMENTS[68600] = Fluid3D([12993,12988,13369,13661],0); -ELEMENTS[68601] = Fluid3D([6492,6652,6525,5935],0); -ELEMENTS[68602] = Fluid3D([12456,11845,12406,11492],0); -ELEMENTS[68603] = Fluid3D([9366,8748,8591,8773],0); -ELEMENTS[68604] = Fluid3D([13381,13838,13116,14323],0); -ELEMENTS[68605] = Fluid3D([13393,12645,12719,13698],0); -ELEMENTS[68606] = Fluid3D([13393,12645,13698,13554],0); -ELEMENTS[68607] = Fluid3D([4734,4745,4720,5150],0); -ELEMENTS[68608] = Fluid3D([11196,11323,10199,10893],0); -ELEMENTS[68609] = Fluid3D([5717,5455,6097,6330],0); -ELEMENTS[68610] = Fluid3D([7347,7928,8233,7511],0); -ELEMENTS[68611] = Fluid3D([8233,7347,7511,7866],0); -ELEMENTS[68612] = Fluid3D([8233,7347,7866,7967],0); -ELEMENTS[68613] = Fluid3D([18533,18609,18473,18524],0); -ELEMENTS[68614] = Fluid3D([17805,17560,17947,17645],0); -ELEMENTS[68615] = Fluid3D([10148,11201,11382,10659],0); -ELEMENTS[68616] = Fluid3D([1933,1907,2025,2170],0); -ELEMENTS[68617] = Fluid3D([8430,7524,8471,7784],0); -ELEMENTS[68618] = Fluid3D([9585,10368,10461,10580],0); -ELEMENTS[68619] = Fluid3D([8863,9573,8885,8389],0); -ELEMENTS[68620] = Fluid3D([9573,8885,8389,8926],0); -ELEMENTS[68621] = Fluid3D([6645,6653,7471,6924],0); -ELEMENTS[68622] = Fluid3D([4143,4039,3590,3982],0); -ELEMENTS[68623] = Fluid3D([14514,15068,14605,13866],0); -ELEMENTS[68624] = Fluid3D([10303,10258,9306,9785],0); -ELEMENTS[68625] = Fluid3D([6763,6571,6149,7089],0); -ELEMENTS[68626] = Fluid3D([2214,2078,2032,1911],0); -ELEMENTS[68627] = Fluid3D([17864,17522,17705,17460],0); -ELEMENTS[68628] = Fluid3D([13646,14307,13292,13278],0); -ELEMENTS[68629] = Fluid3D([6527,6855,7647,6797],0); -ELEMENTS[68630] = Fluid3D([16036,16412,16204,15562],0); -ELEMENTS[68631] = Fluid3D([17774,17894,17984,17612],0); -ELEMENTS[68632] = Fluid3D([11705,11801,10640,10859],0); -ELEMENTS[68633] = Fluid3D([8877,8649,7794,7740],0); -ELEMENTS[68634] = Fluid3D([5573,5790,6221,6004],0); -ELEMENTS[68635] = Fluid3D([12253,12043,12754,11545],0); -ELEMENTS[68636] = Fluid3D([12518,12179,11852,11635],0); -ELEMENTS[68637] = Fluid3D([11852,12518,11635,11861],0); -ELEMENTS[68638] = Fluid3D([14233,13731,13744,13079],0); -ELEMENTS[68639] = Fluid3D([13744,14233,13079,13705],0); -ELEMENTS[68640] = Fluid3D([13079,13744,13705,13504],0); -ELEMENTS[68641] = Fluid3D([13079,13744,13504,13043],0); -ELEMENTS[68642] = Fluid3D([13744,13504,13043,13857],0); -ELEMENTS[68643] = Fluid3D([13744,13504,13857,14444],0); -ELEMENTS[68644] = Fluid3D([13043,13744,13857,13503],0); -ELEMENTS[68645] = Fluid3D([13744,13705,13504,14330],0); -ELEMENTS[68646] = Fluid3D([13079,13744,13043,13503],0); -ELEMENTS[68647] = Fluid3D([13744,14233,13705,14806],0); -ELEMENTS[68648] = Fluid3D([18651,18689,18677,18671],0); -ELEMENTS[68649] = Fluid3D([15449,15105,14808,15472],0); -ELEMENTS[68650] = Fluid3D([11359,10909,11463,10410],0); -ELEMENTS[68651] = Fluid3D([4007,4083,4493,4134],0); -ELEMENTS[68652] = Fluid3D([4083,4493,4134,3755],0); -ELEMENTS[68653] = Fluid3D([16394,16098,16650,16445],0); -ELEMENTS[68654] = Fluid3D([16650,16394,16445,17031],0); -ELEMENTS[68655] = Fluid3D([12637,13608,13634,13257],0); -ELEMENTS[68656] = Fluid3D([16287,16548,16317,16756],0); -ELEMENTS[68657] = Fluid3D([12114,12579,12476,11779],0); -ELEMENTS[68658] = Fluid3D([4361,4267,3856,4232],0); -ELEMENTS[68659] = Fluid3D([14589,13858,14479,13993],0); -ELEMENTS[68660] = Fluid3D([17423,17315,17144,17003],0); -ELEMENTS[68661] = Fluid3D([12164,12670,12883,11969],0); -ELEMENTS[68662] = Fluid3D([12106,11436,12328,11513],0); -ELEMENTS[68663] = Fluid3D([11900,12525,12418,12587],0); -ELEMENTS[68664] = Fluid3D([13922,13343,13091,12851],0); -ELEMENTS[68665] = Fluid3D([17032,17182,17316,17398],0); -ELEMENTS[68666] = Fluid3D([17032,17182,17398,16922],0); -ELEMENTS[68667] = Fluid3D([14784,14249,14946,13985],0); -ELEMENTS[68668] = Fluid3D([14784,14249,13985,13914],0); -ELEMENTS[68669] = Fluid3D([7133,7156,6491,6937],0); -ELEMENTS[68670] = Fluid3D([3247,3132,2957,3075],0); -ELEMENTS[68671] = Fluid3D([11968,12250,11268,12243],0); -ELEMENTS[68672] = Fluid3D([11917,10924,11009,11204],0); -ELEMENTS[68673] = Fluid3D([16281,15910,15631,15548],0); -ELEMENTS[68674] = Fluid3D([13664,13219,12850,12658],0); -ELEMENTS[68675] = Fluid3D([6432,6679,7312,7223],0); -ELEMENTS[68676] = Fluid3D([6987,7158,6316,6746],0); -ELEMENTS[68677] = Fluid3D([3777,3460,3862,3898],0); -ELEMENTS[68678] = Fluid3D([3777,3460,3898,3902],0); -ELEMENTS[68679] = Fluid3D([3898,3777,3902,4171],0); -ELEMENTS[68680] = Fluid3D([3902,3898,4171,4352],0); -ELEMENTS[68681] = Fluid3D([3898,3777,4171,3862],0); -ELEMENTS[68682] = Fluid3D([3460,3898,3902,3763],0); -ELEMENTS[68683] = Fluid3D([3898,3902,3763,4352],0); -ELEMENTS[68684] = Fluid3D([4171,3902,4352,4384],0); -ELEMENTS[68685] = Fluid3D([4171,3902,4384,3880],0); -ELEMENTS[68686] = Fluid3D([4171,3902,3880,3777],0); -ELEMENTS[68687] = Fluid3D([3460,3898,3763,3853],0); -ELEMENTS[68688] = Fluid3D([3898,3763,3853,4441],0); -ELEMENTS[68689] = Fluid3D([4171,3898,3862,4441],0); -ELEMENTS[68690] = Fluid3D([4171,3898,4441,4352],0); -ELEMENTS[68691] = Fluid3D([3460,3862,3898,3853],0); -ELEMENTS[68692] = Fluid3D([15291,15775,15374,15594],0); -ELEMENTS[68693] = Fluid3D([7025,7489,8048,6988],0); -ELEMENTS[68694] = Fluid3D([16608,16725,16266,16997],0); -ELEMENTS[68695] = Fluid3D([13652,13879,13633,13157],0); -ELEMENTS[68696] = Fluid3D([13652,13879,13157,13272],0); -ELEMENTS[68697] = Fluid3D([13879,13633,13157,13337],0); -ELEMENTS[68698] = Fluid3D([5212,5332,5016,4763],0); -ELEMENTS[68699] = Fluid3D([12737,13754,13139,13475],0); -ELEMENTS[68700] = Fluid3D([14883,14785,14946,15439],0); -ELEMENTS[68701] = Fluid3D([14946,14883,15439,15743],0); -ELEMENTS[68702] = Fluid3D([17923,17584,17727,17705],0); -ELEMENTS[68703] = Fluid3D([12804,12609,12816,12004],0); -ELEMENTS[68704] = Fluid3D([12804,12609,12004,11708],0); -ELEMENTS[68705] = Fluid3D([12609,12816,12004,11622],0); -ELEMENTS[68706] = Fluid3D([12816,12004,11622,11699],0); -ELEMENTS[68707] = Fluid3D([12004,11622,11699,11708],0); -ELEMENTS[68708] = Fluid3D([12004,12609,11622,11708],0); -ELEMENTS[68709] = Fluid3D([11133,10309,10326,10110],0); -ELEMENTS[68710] = Fluid3D([4048,4431,4606,3876],0); -ELEMENTS[68711] = Fluid3D([13197,13802,13438,14054],0); -ELEMENTS[68712] = Fluid3D([7841,7890,7602,7035],0); -ELEMENTS[68713] = Fluid3D([8494,8054,8181,7416],0); -ELEMENTS[68714] = Fluid3D([8542,8245,8058,9086],0); -ELEMENTS[68715] = Fluid3D([18431,18414,18287,18525],0); -ELEMENTS[68716] = Fluid3D([9400,8485,9131,9286],0); -ELEMENTS[68717] = Fluid3D([2813,2819,3038,3158],0); -ELEMENTS[68718] = Fluid3D([12716,11990,13104,12416],0); -ELEMENTS[68719] = Fluid3D([11990,13104,12416,11993],0); -ELEMENTS[68720] = Fluid3D([16599,16660,17117,16979],0); -ELEMENTS[68721] = Fluid3D([16660,17117,16979,16601],0); -ELEMENTS[68722] = Fluid3D([16660,17117,16601,17158],0); -ELEMENTS[68723] = Fluid3D([16660,17117,17158,17050],0); -ELEMENTS[68724] = Fluid3D([15689,15470,15668,16149],0); -ELEMENTS[68725] = Fluid3D([8460,8282,7904,8358],0); -ELEMENTS[68726] = Fluid3D([8460,8282,8358,9353],0); -ELEMENTS[68727] = Fluid3D([14602,14489,15188,14297],0); -ELEMENTS[68728] = Fluid3D([14602,14489,14297,13743],0); -ELEMENTS[68729] = Fluid3D([14297,14602,13743,14488],0); -ELEMENTS[68730] = Fluid3D([13743,14297,14488,14482],0); -ELEMENTS[68731] = Fluid3D([13743,14297,14482,14070],0); -ELEMENTS[68732] = Fluid3D([14297,14482,14070,14489],0); -ELEMENTS[68733] = Fluid3D([14297,14602,14488,15188],0); -ELEMENTS[68734] = Fluid3D([14489,14297,13743,14070],0); -ELEMENTS[68735] = Fluid3D([14297,14488,14482,15188],0); -ELEMENTS[68736] = Fluid3D([14482,14297,15188,14489],0); -ELEMENTS[68737] = Fluid3D([7197,6958,7354,7950],0); -ELEMENTS[68738] = Fluid3D([6319,6927,6768,6203],0); -ELEMENTS[68739] = Fluid3D([6319,6927,6203,6132],0); -ELEMENTS[68740] = Fluid3D([17572,17666,17953,17766],0); -ELEMENTS[68741] = Fluid3D([13142,12231,12167,13049],0); -ELEMENTS[68742] = Fluid3D([10869,10704,11307,11781],0); -ELEMENTS[68743] = Fluid3D([16036,15619,15325,15844],0); -ELEMENTS[68744] = Fluid3D([7984,7981,7467,6772],0); -ELEMENTS[68745] = Fluid3D([7023,6710,7053,6234],0); -ELEMENTS[68746] = Fluid3D([6504,5947,6802,6530],0); -ELEMENTS[68747] = Fluid3D([6504,5947,6530,6164],0); -ELEMENTS[68748] = Fluid3D([6212,5974,6460,6838],0); -ELEMENTS[68749] = Fluid3D([7413,7081,7368,6299],0); -ELEMENTS[68750] = Fluid3D([5443,5822,5369,4880],0); -ELEMENTS[68751] = Fluid3D([17101,16605,16839,16924],0); -ELEMENTS[68752] = Fluid3D([4462,4552,4031,4496],0); -ELEMENTS[68753] = Fluid3D([4446,4217,3890,3760],0); -ELEMENTS[68754] = Fluid3D([11054,11837,11273,10562],0); -ELEMENTS[68755] = Fluid3D([16442,15869,15885,16250],0); -ELEMENTS[68756] = Fluid3D([9835,9057,9252,9894],0); -ELEMENTS[68757] = Fluid3D([9835,9057,9894,9811],0); -ELEMENTS[68758] = Fluid3D([2927,2715,3122,2920],0); -ELEMENTS[68759] = Fluid3D([3122,2927,2920,3313],0); -ELEMENTS[68760] = Fluid3D([9234,9942,9317,9484],0); -ELEMENTS[68761] = Fluid3D([12123,11395,10865,11441],0); -ELEMENTS[68762] = Fluid3D([8198,8096,7316,7728],0); -ELEMENTS[68763] = Fluid3D([16120,16502,16265,16694],0); -ELEMENTS[68764] = Fluid3D([16120,16502,16694,16406],0); -ELEMENTS[68765] = Fluid3D([7692,7578,7043,6745],0); -ELEMENTS[68766] = Fluid3D([17116,17291,16801,16945],0); -ELEMENTS[68767] = Fluid3D([13392,12958,13749,12519],0); -ELEMENTS[68768] = Fluid3D([12739,12650,13297,13711],0); -ELEMENTS[68769] = Fluid3D([7435,8145,8177,7305],0); -ELEMENTS[68770] = Fluid3D([16640,16285,16752,16383],0); -ELEMENTS[68771] = Fluid3D([11560,12622,11551,12933],0); -ELEMENTS[68772] = Fluid3D([16067,16194,16632,16346],0); -ELEMENTS[68773] = Fluid3D([17619,17337,17136,17236],0); -ELEMENTS[68774] = Fluid3D([9820,9252,10134,10283],0); -ELEMENTS[68775] = Fluid3D([9820,9252,10283,9103],0); -ELEMENTS[68776] = Fluid3D([7041,6250,6337,6755],0); -ELEMENTS[68777] = Fluid3D([14865,14270,14843,14148],0); -ELEMENTS[68778] = Fluid3D([14843,14865,14148,14929],0); -ELEMENTS[68779] = Fluid3D([14843,14865,14929,15820],0); -ELEMENTS[68780] = Fluid3D([14865,14270,14148,14929],0); -ELEMENTS[68781] = Fluid3D([14865,14270,14929,15149],0); -ELEMENTS[68782] = Fluid3D([6191,6173,6316,5601],0); -ELEMENTS[68783] = Fluid3D([8444,8968,9373,8424],0); -ELEMENTS[68784] = Fluid3D([9373,8444,8424,9111],0); -ELEMENTS[68785] = Fluid3D([16066,16253,16207,16699],0); -ELEMENTS[68786] = Fluid3D([16253,16207,16699,16449],0); -ELEMENTS[68787] = Fluid3D([18168,18274,18063,18096],0); -ELEMENTS[68788] = Fluid3D([15025,14634,15552,15207],0); -ELEMENTS[68789] = Fluid3D([13489,12675,12881,12020],0); -ELEMENTS[68790] = Fluid3D([7763,7091,7242,8251],0); -ELEMENTS[68791] = Fluid3D([16026,15296,15390,15295],0); -ELEMENTS[68792] = Fluid3D([8350,7475,7501,8296],0); -ELEMENTS[68793] = Fluid3D([8350,7475,8296,8166],0); -ELEMENTS[68794] = Fluid3D([11508,11401,10914,11968],0); -ELEMENTS[68795] = Fluid3D([5772,6433,6168,5976],0); -ELEMENTS[68796] = Fluid3D([12224,12635,12932,13051],0); -ELEMENTS[68797] = Fluid3D([15955,16290,15416,15761],0); -ELEMENTS[68798] = Fluid3D([5311,5031,5524,5530],0); -ELEMENTS[68799] = Fluid3D([12047,12091,12824,12481],0); -ELEMENTS[68800] = Fluid3D([13845,13891,13917,14468],0); -ELEMENTS[68801] = Fluid3D([13932,13307,14116,13992],0); -ELEMENTS[68802] = Fluid3D([13932,13307,13992,13926],0); -ELEMENTS[68803] = Fluid3D([14975,14568,14453,15485],0); -ELEMENTS[68804] = Fluid3D([15836,16227,16591,16369],0); -ELEMENTS[68805] = Fluid3D([16227,16591,16369,16893],0); -ELEMENTS[68806] = Fluid3D([15836,16227,16369,16000],0); -ELEMENTS[68807] = Fluid3D([16227,16369,16000,16513],0); -ELEMENTS[68808] = Fluid3D([16227,16369,16513,16893],0); -ELEMENTS[68809] = Fluid3D([18074,17873,18108,17692],0); -ELEMENTS[68810] = Fluid3D([18367,18198,18309,18179],0); -ELEMENTS[68811] = Fluid3D([10886,10191,10916,9618],0); -ELEMENTS[68812] = Fluid3D([15421,15977,15715,15313],0); -ELEMENTS[68813] = Fluid3D([15715,15421,15313,14802],0); -ELEMENTS[68814] = Fluid3D([15421,15313,14802,15545],0); -ELEMENTS[68815] = Fluid3D([15813,15247,15407,15996],0); -ELEMENTS[68816] = Fluid3D([6714,7249,7497,7740],0); -ELEMENTS[68817] = Fluid3D([10010,10004,11131,11474],0); -ELEMENTS[68818] = Fluid3D([12652,12950,13334,12273],0); -ELEMENTS[68819] = Fluid3D([17281,16929,17160,16661],0); -ELEMENTS[68820] = Fluid3D([18313,18276,18480,18474],0); -ELEMENTS[68821] = Fluid3D([12063,12021,11322,10864],0); -ELEMENTS[68822] = Fluid3D([4838,4318,4641,4449],0); -ELEMENTS[68823] = Fluid3D([11610,11013,11229,11440],0); -ELEMENTS[68824] = Fluid3D([11610,11013,11440,11732],0); -ELEMENTS[68825] = Fluid3D([5616,5116,5144,4991],0); -ELEMENTS[68826] = Fluid3D([4802,5057,5414,4897],0); -ELEMENTS[68827] = Fluid3D([5057,5414,4897,5334],0); -ELEMENTS[68828] = Fluid3D([5414,4802,4897,5218],0); -ELEMENTS[68829] = Fluid3D([4897,5414,5218,5445],0); -ELEMENTS[68830] = Fluid3D([4802,5057,4897,4305],0); -ELEMENTS[68831] = Fluid3D([4897,4802,4305,4489],0); -ELEMENTS[68832] = Fluid3D([4897,4802,4489,5218],0); -ELEMENTS[68833] = Fluid3D([13688,13083,12606,13403],0); -ELEMENTS[68834] = Fluid3D([4494,4521,4369,3890],0); -ELEMENTS[68835] = Fluid3D([2496,2340,2555,2742],0); -ELEMENTS[68836] = Fluid3D([9009,9680,10098,9463],0); -ELEMENTS[68837] = Fluid3D([6537,6708,5773,6073],0); -ELEMENTS[68838] = Fluid3D([9554,9299,10289,9375],0); -ELEMENTS[68839] = Fluid3D([7874,8470,7929,7235],0); -ELEMENTS[68840] = Fluid3D([18578,18584,18643,18520],0); -ELEMENTS[68841] = Fluid3D([4450,4268,4070,3692],0); -ELEMENTS[68842] = Fluid3D([16077,16209,15559,15906],0); -ELEMENTS[68843] = Fluid3D([16690,16982,17042,16952],0); -ELEMENTS[68844] = Fluid3D([2116,2410,2250,2340],0); -ELEMENTS[68845] = Fluid3D([6465,6318,5801,6824],0); -ELEMENTS[68846] = Fluid3D([11429,10711,11963,11149],0); -ELEMENTS[68847] = Fluid3D([2582,2364,2301,2735],0); -ELEMENTS[68848] = Fluid3D([17462,17391,17570,17026],0); -ELEMENTS[68849] = Fluid3D([16494,16223,16129,15978],0); -ELEMENTS[68850] = Fluid3D([16494,16223,15978,16039],0); -ELEMENTS[68851] = Fluid3D([15978,16494,16039,15804],0); -ELEMENTS[68852] = Fluid3D([16039,15978,15804,15723],0); -ELEMENTS[68853] = Fluid3D([16039,15978,15723,16223],0); -ELEMENTS[68854] = Fluid3D([15978,15723,16223,16129],0); -ELEMENTS[68855] = Fluid3D([15978,15804,15723,16129],0); -ELEMENTS[68856] = Fluid3D([15978,15804,16129,16494],0); -ELEMENTS[68857] = Fluid3D([9474,10599,10503,9567],0); -ELEMENTS[68858] = Fluid3D([7263,8074,7795,7781],0); -ELEMENTS[68859] = Fluid3D([17825,17576,17976,18033],0); -ELEMENTS[68860] = Fluid3D([4724,4638,5195,4425],0); -ELEMENTS[68861] = Fluid3D([11080,10664,11795,10339],0); -ELEMENTS[68862] = Fluid3D([17291,17456,17768,17613],0); -ELEMENTS[68863] = Fluid3D([8875,9257,9148,10414],0); -ELEMENTS[68864] = Fluid3D([17125,16684,17093,16766],0); -ELEMENTS[68865] = Fluid3D([15031,15461,15183,15441],0); -ELEMENTS[68866] = Fluid3D([15461,15183,15441,16114],0); -ELEMENTS[68867] = Fluid3D([12669,12788,11849,11927],0); -ELEMENTS[68868] = Fluid3D([3786,3913,3949,4390],0); -ELEMENTS[68869] = Fluid3D([3913,3949,4390,4159],0); -ELEMENTS[68870] = Fluid3D([3913,3949,4159,3497],0); -ELEMENTS[68871] = Fluid3D([3336,3577,3505,4032],0); -ELEMENTS[68872] = Fluid3D([7456,7510,7190,8178],0); -ELEMENTS[68873] = Fluid3D([6245,5767,6431,6102],0); -ELEMENTS[68874] = Fluid3D([13374,13176,12504,12378],0); -ELEMENTS[68875] = Fluid3D([6969,7459,6643,6995],0); -ELEMENTS[68876] = Fluid3D([14043,14319,13626,13619],0); -ELEMENTS[68877] = Fluid3D([10289,10344,9375,10544],0); -ELEMENTS[68878] = Fluid3D([9466,9152,9793,8846],0); -ELEMENTS[68879] = Fluid3D([9793,9466,8846,9828],0); -ELEMENTS[68880] = Fluid3D([9793,9466,9828,10357],0); -ELEMENTS[68881] = Fluid3D([2745,2868,2739,2592],0); -ELEMENTS[68882] = Fluid3D([10216,10990,11239,10209],0); -ELEMENTS[68883] = Fluid3D([3483,3922,3610,3508],0); -ELEMENTS[68884] = Fluid3D([12876,12174,12474,13157],0); -ELEMENTS[68885] = Fluid3D([14391,14528,14540,13955],0); -ELEMENTS[68886] = Fluid3D([14540,14391,13955,14444],0); -ELEMENTS[68887] = Fluid3D([14528,14540,13955,14539],0); -ELEMENTS[68888] = Fluid3D([3510,3209,3417,3035],0); -ELEMENTS[68889] = Fluid3D([11896,11781,10727,11927],0); -ELEMENTS[68890] = Fluid3D([15875,15987,15860,16566],0); -ELEMENTS[68891] = Fluid3D([15875,15987,16566,16665],0); -ELEMENTS[68892] = Fluid3D([10132,10943,10536,10927],0); -ELEMENTS[68893] = Fluid3D([5004,5077,4968,5586],0); -ELEMENTS[68894] = Fluid3D([15816,16346,16300,16194],0); -ELEMENTS[68895] = Fluid3D([6342,5795,6321,5916],0); -ELEMENTS[68896] = Fluid3D([7997,7519,7745,7856],0); -ELEMENTS[68897] = Fluid3D([15946,15682,15892,15223],0); -ELEMENTS[68898] = Fluid3D([10131,9294,9549,9756],0); -ELEMENTS[68899] = Fluid3D([15685,15369,15628,16329],0); -ELEMENTS[68900] = Fluid3D([8898,8438,7919,7856],0); -ELEMENTS[68901] = Fluid3D([14456,15229,15273,14552],0); -ELEMENTS[68902] = Fluid3D([9661,8773,9387,8792],0); -ELEMENTS[68903] = Fluid3D([18555,18595,18565,18452],0); -ELEMENTS[68904] = Fluid3D([3922,4339,4404,4375],0); -ELEMENTS[68905] = Fluid3D([9230,10330,9393,9819],0); -ELEMENTS[68906] = Fluid3D([13659,13614,14609,14369],0); -ELEMENTS[68907] = Fluid3D([13659,13614,14369,13790],0); -ELEMENTS[68908] = Fluid3D([16131,16123,16544,15701],0); -ELEMENTS[68909] = Fluid3D([3432,3340,3692,3813],0); -ELEMENTS[68910] = Fluid3D([3035,3189,2703,2728],0); -ELEMENTS[68911] = Fluid3D([12303,12154,12253,11424],0); -ELEMENTS[68912] = Fluid3D([8496,7967,8314,7466],0); -ELEMENTS[68913] = Fluid3D([4062,4069,3802,4231],0); -ELEMENTS[68914] = Fluid3D([14004,13919,13509,13035],0); -ELEMENTS[68915] = Fluid3D([7223,7216,6490,6679],0); -ELEMENTS[68916] = Fluid3D([8289,9185,8650,8747],0); -ELEMENTS[68917] = Fluid3D([8289,9185,8747,9801],0); -ELEMENTS[68918] = Fluid3D([7257,6500,7123,7477],0); -ELEMENTS[68919] = Fluid3D([18633,18580,18546,18566],0); -ELEMENTS[68920] = Fluid3D([18546,18633,18566,18590],0); -ELEMENTS[68921] = Fluid3D([18566,18546,18590,18437],0); -ELEMENTS[68922] = Fluid3D([18580,18546,18566,18426],0); -ELEMENTS[68923] = Fluid3D([18546,18566,18426,18437],0); -ELEMENTS[68924] = Fluid3D([15347,15963,16070,15524],0); -ELEMENTS[68925] = Fluid3D([15963,16070,15524,15888],0); -ELEMENTS[68926] = Fluid3D([15963,16070,15888,16577],0); -ELEMENTS[68927] = Fluid3D([15888,15963,16577,16249],0); -ELEMENTS[68928] = Fluid3D([15888,15963,16249,15556],0); -ELEMENTS[68929] = Fluid3D([15888,15963,15556,15241],0); -ELEMENTS[68930] = Fluid3D([15888,15963,15241,15524],0); -ELEMENTS[68931] = Fluid3D([13914,13886,13317,13985],0); -ELEMENTS[68932] = Fluid3D([17962,17880,17633,17713],0); -ELEMENTS[68933] = Fluid3D([15444,14831,15492,15436],0); -ELEMENTS[68934] = Fluid3D([15444,14831,15436,14495],0); -ELEMENTS[68935] = Fluid3D([16084,15988,15730,15346],0); -ELEMENTS[68936] = Fluid3D([1812,1752,1828,1888],0); -ELEMENTS[68937] = Fluid3D([4956,4914,5369,5537],0); -ELEMENTS[68938] = Fluid3D([9583,8584,8822,9109],0); -ELEMENTS[68939] = Fluid3D([14403,13484,14157,13716],0); -ELEMENTS[68940] = Fluid3D([6376,6479,5847,6185],0); -ELEMENTS[68941] = Fluid3D([6376,6479,6185,7025],0); -ELEMENTS[68942] = Fluid3D([11489,10472,11121,11429],0); -ELEMENTS[68943] = Fluid3D([10387,10515,10603,9657],0); -ELEMENTS[68944] = Fluid3D([17736,17942,17729,17487],0); -ELEMENTS[68945] = Fluid3D([9438,9173,9598,9002],0); -ELEMENTS[68946] = Fluid3D([9173,9598,9002,9728],0); -ELEMENTS[68947] = Fluid3D([14039,14883,14946,13900],0); -ELEMENTS[68948] = Fluid3D([7870,7641,7717,7135],0); -ELEMENTS[68949] = Fluid3D([7870,7641,7135,7081],0); -ELEMENTS[68950] = Fluid3D([7870,7641,7081,7368],0); -ELEMENTS[68951] = Fluid3D([7135,7870,7081,6772],0); -ELEMENTS[68952] = Fluid3D([7081,7135,6772,6278],0); -ELEMENTS[68953] = Fluid3D([7870,7081,6772,7368],0); -ELEMENTS[68954] = Fluid3D([7081,6772,7368,6480],0); -ELEMENTS[68955] = Fluid3D([7081,6772,6480,6008],0); -ELEMENTS[68956] = Fluid3D([6772,6480,6008,6738],0); -ELEMENTS[68957] = Fluid3D([7368,7081,6480,6299],0); -ELEMENTS[68958] = Fluid3D([7081,6480,6299,6008],0); -ELEMENTS[68959] = Fluid3D([6480,6299,6008,6263],0); -ELEMENTS[68960] = Fluid3D([6480,6299,6263,6738],0); -ELEMENTS[68961] = Fluid3D([6263,6480,6738,6008],0); -ELEMENTS[68962] = Fluid3D([6738,6263,6008,6152],0); -ELEMENTS[68963] = Fluid3D([6480,6299,6738,7368],0); -ELEMENTS[68964] = Fluid3D([6738,6480,7368,6772],0); -ELEMENTS[68965] = Fluid3D([6299,6263,6738,6957],0); -ELEMENTS[68966] = Fluid3D([6263,6738,6957,6460],0); -ELEMENTS[68967] = Fluid3D([6772,7081,6278,6008],0); -ELEMENTS[68968] = Fluid3D([17004,17082,17173,16664],0); -ELEMENTS[68969] = Fluid3D([5303,5258,5824,5995],0); -ELEMENTS[68970] = Fluid3D([5258,5824,5995,5610],0); -ELEMENTS[68971] = Fluid3D([16013,15651,15986,16240],0); -ELEMENTS[68972] = Fluid3D([4991,4758,4640,4263],0); -ELEMENTS[68973] = Fluid3D([11070,11885,10699,11079],0); -ELEMENTS[68974] = Fluid3D([6997,7737,6899,7401],0); -ELEMENTS[68975] = Fluid3D([8269,7810,8748,8591],0); -ELEMENTS[68976] = Fluid3D([8748,8269,8591,8773],0); -ELEMENTS[68977] = Fluid3D([7760,7142,8360,7427],0); -ELEMENTS[68978] = Fluid3D([7760,7142,7427,7599],0); -ELEMENTS[68979] = Fluid3D([18510,18480,18603,18599],0); -ELEMENTS[68980] = Fluid3D([18510,18480,18599,18567],0); -ELEMENTS[68981] = Fluid3D([8365,8669,8852,8049],0); -ELEMENTS[68982] = Fluid3D([2997,2683,3135,3198],0); -ELEMENTS[68983] = Fluid3D([8002,8832,8699,8151],0); -ELEMENTS[68984] = Fluid3D([18447,18506,18457,18328],0); -ELEMENTS[68985] = Fluid3D([8673,9656,9254,8449],0); -ELEMENTS[68986] = Fluid3D([16280,16708,16798,16327],0); -ELEMENTS[68987] = Fluid3D([5825,5663,5541,5234],0); -ELEMENTS[68988] = Fluid3D([5541,5825,5234,5747],0); -ELEMENTS[68989] = Fluid3D([9279,10154,9859,9082],0); -ELEMENTS[68990] = Fluid3D([7259,7960,6772,7984],0); -ELEMENTS[68991] = Fluid3D([8757,8865,8706,8303],0); -ELEMENTS[68992] = Fluid3D([7762,7470,8710,8426],0); -ELEMENTS[68993] = Fluid3D([2583,2355,2241,2453],0); -ELEMENTS[68994] = Fluid3D([9030,8768,9241,9734],0); -ELEMENTS[68995] = Fluid3D([15232,14869,15385,15484],0); -ELEMENTS[68996] = Fluid3D([18480,18510,18363,18411],0); -ELEMENTS[68997] = Fluid3D([16818,17088,17108,17402],0); -ELEMENTS[68998] = Fluid3D([17121,17300,17145,16601],0); -ELEMENTS[68999] = Fluid3D([15939,16499,16097,15916],0); -ELEMENTS[69000] = Fluid3D([4520,4159,4777,4240],0); -ELEMENTS[69001] = Fluid3D([15939,15933,16499,16362],0); -ELEMENTS[69002] = Fluid3D([16499,15939,16362,15916],0); -ELEMENTS[69003] = Fluid3D([15488,16044,15802,15085],0); -ELEMENTS[69004] = Fluid3D([9177,10157,9837,9723],0); -ELEMENTS[69005] = Fluid3D([8728,9554,9703,9375],0); -ELEMENTS[69006] = Fluid3D([13145,13046,13898,12738],0); -ELEMENTS[69007] = Fluid3D([8084,8792,7826,7725],0); -ELEMENTS[69008] = Fluid3D([8084,8792,7725,7606],0); -ELEMENTS[69009] = Fluid3D([7725,8084,7606,6968],0); -ELEMENTS[69010] = Fluid3D([7606,7725,6968,6750],0); -ELEMENTS[69011] = Fluid3D([6166,6259,6615,6868],0); -ELEMENTS[69012] = Fluid3D([6166,6259,6868,6736],0); -ELEMENTS[69013] = Fluid3D([6166,6259,6736,5887],0); -ELEMENTS[69014] = Fluid3D([6868,6166,6736,6600],0); -ELEMENTS[69015] = Fluid3D([15176,14838,15288,14243],0); -ELEMENTS[69016] = Fluid3D([10956,11706,10102,10958],0); -ELEMENTS[69017] = Fluid3D([16065,15549,15162,15784],0); -ELEMENTS[69018] = Fluid3D([15478,15914,15586,15767],0); -ELEMENTS[69019] = Fluid3D([14728,14158,14594,14416],0); -ELEMENTS[69020] = Fluid3D([10927,11266,10354,11736],0); -ELEMENTS[69021] = Fluid3D([10927,11266,11736,11357],0); -ELEMENTS[69022] = Fluid3D([6720,6466,5944,6109],0); -ELEMENTS[69023] = Fluid3D([3187,3203,3485,3688],0); -ELEMENTS[69024] = Fluid3D([16379,16425,16825,16438],0); -ELEMENTS[69025] = Fluid3D([16825,16379,16438,16002],0); -ELEMENTS[69026] = Fluid3D([14664,14592,14180,15146],0); -ELEMENTS[69027] = Fluid3D([16951,17075,17314,17351],0); -ELEMENTS[69028] = Fluid3D([16951,17075,17351,16975],0); -ELEMENTS[69029] = Fluid3D([6608,6073,5758,6093],0); -ELEMENTS[69030] = Fluid3D([5332,5481,5016,5324],0); -ELEMENTS[69031] = Fluid3D([17650,17748,17752,18097],0); -ELEMENTS[69032] = Fluid3D([12647,12733,13141,12459],0); -ELEMENTS[69033] = Fluid3D([14227,13856,13330,14045],0); -ELEMENTS[69034] = Fluid3D([11135,11820,11978,10638],0); -ELEMENTS[69035] = Fluid3D([5397,6183,5924,5704],0); -ELEMENTS[69036] = Fluid3D([6120,6203,5632,5994],0); -ELEMENTS[69037] = Fluid3D([6203,5632,5994,5545],0); -ELEMENTS[69038] = Fluid3D([13439,12950,12541,13580],0); -ELEMENTS[69039] = Fluid3D([4327,4433,4911,4756],0); -ELEMENTS[69040] = Fluid3D([4425,4794,4930,5195],0); -ELEMENTS[69041] = Fluid3D([1831,1861,1997,2007],0); -ELEMENTS[69042] = Fluid3D([1831,1861,2007,1960],0); -ELEMENTS[69043] = Fluid3D([1861,2007,1960,1816],0); -ELEMENTS[69044] = Fluid3D([1861,1997,2007,1956],0); -ELEMENTS[69045] = Fluid3D([2007,1861,1956,2098],0); -ELEMENTS[69046] = Fluid3D([2007,1831,1960,1997],0); -ELEMENTS[69047] = Fluid3D([2007,1861,2098,1875],0); -ELEMENTS[69048] = Fluid3D([2007,1861,1875,1816],0); -ELEMENTS[69049] = Fluid3D([13596,13611,12678,13175],0); -ELEMENTS[69050] = Fluid3D([3631,3331,3300,3175],0); -ELEMENTS[69051] = Fluid3D([9157,10078,9918,9614],0); -ELEMENTS[69052] = Fluid3D([4320,4859,4290,4509],0); -ELEMENTS[69053] = Fluid3D([10322,10778,11284,11104],0); -ELEMENTS[69054] = Fluid3D([13699,13949,13276,14090],0); -ELEMENTS[69055] = Fluid3D([13699,13949,14090,14717],0); -ELEMENTS[69056] = Fluid3D([13949,14090,14717,14275],0); -ELEMENTS[69057] = Fluid3D([14090,14717,14275,14338],0); -ELEMENTS[69058] = Fluid3D([14275,14090,14338,13518],0); -ELEMENTS[69059] = Fluid3D([13949,14090,14275,13276],0); -ELEMENTS[69060] = Fluid3D([14090,14275,13276,13518],0); -ELEMENTS[69061] = Fluid3D([14090,14338,13518,14717],0); -ELEMENTS[69062] = Fluid3D([13699,13949,14717,14476],0); -ELEMENTS[69063] = Fluid3D([14090,13699,14717,13518],0); -ELEMENTS[69064] = Fluid3D([14090,13699,13518,13276],0); -ELEMENTS[69065] = Fluid3D([18692,18684,18674,18656],0); -ELEMENTS[69066] = Fluid3D([10065,9308,10873,9622],0); -ELEMENTS[69067] = Fluid3D([10065,9308,9622,10003],0); -ELEMENTS[69068] = Fluid3D([3990,3879,3553,4105],0); -ELEMENTS[69069] = Fluid3D([13016,13794,13146,12525],0); -ELEMENTS[69070] = Fluid3D([12870,12618,13018,12433],0); -ELEMENTS[69071] = Fluid3D([11411,11525,10811,11702],0); -ELEMENTS[69072] = Fluid3D([11411,11525,11702,12619],0); -ELEMENTS[69073] = Fluid3D([7936,8657,8153,9393],0); -ELEMENTS[69074] = Fluid3D([2866,2825,2627,2558],0); -ELEMENTS[69075] = Fluid3D([2866,2825,2558,2781],0); -ELEMENTS[69076] = Fluid3D([2866,2825,2781,3239],0); -ELEMENTS[69077] = Fluid3D([6320,5780,6114,6248],0); -ELEMENTS[69078] = Fluid3D([18192,18211,18034,18241],0); -ELEMENTS[69079] = Fluid3D([18192,18211,18241,18441],0); -ELEMENTS[69080] = Fluid3D([10010,9135,9857,9682],0); -ELEMENTS[69081] = Fluid3D([10316,10222,9310,9216],0); -ELEMENTS[69082] = Fluid3D([8916,8343,7790,8121],0); -ELEMENTS[69083] = Fluid3D([2167,2026,2283,2034],0); -ELEMENTS[69084] = Fluid3D([2354,2542,2476,2524],0); -ELEMENTS[69085] = Fluid3D([2354,2542,2524,2648],0); -ELEMENTS[69086] = Fluid3D([18165,18048,18056,18352],0); -ELEMENTS[69087] = Fluid3D([2263,2384,2385,2680],0); -ELEMENTS[69088] = Fluid3D([4268,4480,3988,3739],0); -ELEMENTS[69089] = Fluid3D([14165,13574,13520,12970],0); -ELEMENTS[69090] = Fluid3D([6349,7491,6461,6148],0); -ELEMENTS[69091] = Fluid3D([6461,6349,6148,5711],0); -ELEMENTS[69092] = Fluid3D([12457,13420,13329,12946],0); -ELEMENTS[69093] = Fluid3D([14020,13550,14252,13564],0); -ELEMENTS[69094] = Fluid3D([16635,16691,16214,16873],0); -ELEMENTS[69095] = Fluid3D([2054,2233,2188,2130],0); -ELEMENTS[69096] = Fluid3D([2233,2188,2130,2401],0); -ELEMENTS[69097] = Fluid3D([2188,2130,2401,2365],0); -ELEMENTS[69098] = Fluid3D([4949,4955,4965,5507],0); -ELEMENTS[69099] = Fluid3D([4949,4955,5507,5139],0); -ELEMENTS[69100] = Fluid3D([4296,4568,4097,4109],0); -ELEMENTS[69101] = Fluid3D([7106,6316,6014,6362],0); -ELEMENTS[69102] = Fluid3D([6316,6014,6362,5783],0); -ELEMENTS[69103] = Fluid3D([6468,6432,7312,6741],0); -ELEMENTS[69104] = Fluid3D([10831,10720,10666,11474],0); -ELEMENTS[69105] = Fluid3D([10666,10831,11474,10010],0); -ELEMENTS[69106] = Fluid3D([5447,5121,5796,5215],0); -ELEMENTS[69107] = Fluid3D([13607,13331,13000,13817],0); -ELEMENTS[69108] = Fluid3D([17722,18063,18038,17813],0); -ELEMENTS[69109] = Fluid3D([6552,7382,7028,7819],0); -ELEMENTS[69110] = Fluid3D([16088,15762,15814,16225],0); -ELEMENTS[69111] = Fluid3D([16088,15762,16225,16558],0); -ELEMENTS[69112] = Fluid3D([13102,13323,13790,14304],0); -ELEMENTS[69113] = Fluid3D([2300,2215,2174,2078],0); -ELEMENTS[69114] = Fluid3D([2300,2215,2078,2041],0); -ELEMENTS[69115] = Fluid3D([5123,5643,5549,5384],0); -ELEMENTS[69116] = Fluid3D([11053,11709,11115,11832],0); -ELEMENTS[69117] = Fluid3D([11053,11709,11832,11908],0); -ELEMENTS[69118] = Fluid3D([15482,14789,15309,15071],0); -ELEMENTS[69119] = Fluid3D([7448,7329,8250,7556],0); -ELEMENTS[69120] = Fluid3D([11476,11436,11466,10797],0); -ELEMENTS[69121] = Fluid3D([5806,6062,6339,6887],0); -ELEMENTS[69122] = Fluid3D([11445,11759,11168,11028],0); -ELEMENTS[69123] = Fluid3D([7831,8355,7731,9051],0); -ELEMENTS[69124] = Fluid3D([13102,12403,12747,13614],0); -ELEMENTS[69125] = Fluid3D([13653,13058,12629,13702],0); -ELEMENTS[69126] = Fluid3D([1922,1870,1862,2038],0); -ELEMENTS[69127] = Fluid3D([1870,1862,2038,1985],0); -ELEMENTS[69128] = Fluid3D([2944,3154,3040,3446],0); -ELEMENTS[69129] = Fluid3D([8334,9139,9090,8230],0); -ELEMENTS[69130] = Fluid3D([9907,10207,9286,9289],0); -ELEMENTS[69131] = Fluid3D([14131,14874,14713,13877],0); -ELEMENTS[69132] = Fluid3D([3989,3802,4116,4214],0); -ELEMENTS[69133] = Fluid3D([15641,15851,15742,15034],0); -ELEMENTS[69134] = Fluid3D([10844,10249,10277,11509],0); -ELEMENTS[69135] = Fluid3D([16116,15344,15636,15784],0); -ELEMENTS[69136] = Fluid3D([10232,10543,9527,9192],0); -ELEMENTS[69137] = Fluid3D([15894,15469,15038,15475],0); -ELEMENTS[69138] = Fluid3D([15633,15637,16134,16084],0); -ELEMENTS[69139] = Fluid3D([15633,15637,16084,15346],0); -ELEMENTS[69140] = Fluid3D([11837,12495,12160,12315],0); -ELEMENTS[69141] = Fluid3D([18263,17971,18051,18110],0); -ELEMENTS[69142] = Fluid3D([11476,11513,11436,10512],0); -ELEMENTS[69143] = Fluid3D([11436,11476,10512,10797],0); -ELEMENTS[69144] = Fluid3D([10512,11436,10797,10728],0); -ELEMENTS[69145] = Fluid3D([10512,11436,10728,10180],0); -ELEMENTS[69146] = Fluid3D([10728,10512,10180,9791],0); -ELEMENTS[69147] = Fluid3D([10728,10512,9791,10797],0); -ELEMENTS[69148] = Fluid3D([10512,9791,10797,10585],0); -ELEMENTS[69149] = Fluid3D([8655,8201,7478,7367],0); -ELEMENTS[69150] = Fluid3D([6461,6214,5711,6515],0); -ELEMENTS[69151] = Fluid3D([6461,6214,6515,7105],0); -ELEMENTS[69152] = Fluid3D([8384,8542,9036,8491],0); -ELEMENTS[69153] = Fluid3D([7105,7495,7059,6531],0); -ELEMENTS[69154] = Fluid3D([6799,6253,6352,6447],0); -ELEMENTS[69155] = Fluid3D([6799,6253,6447,7236],0); -ELEMENTS[69156] = Fluid3D([6799,6253,7236,6984],0); -ELEMENTS[69157] = Fluid3D([4983,4449,4673,4838],0); -ELEMENTS[69158] = Fluid3D([13544,13352,14376,13979],0); -ELEMENTS[69159] = Fluid3D([7536,7416,7788,8494],0); -ELEMENTS[69160] = Fluid3D([7788,7536,8494,8378],0); -ELEMENTS[69161] = Fluid3D([12245,11897,12977,12062],0); -ELEMENTS[69162] = Fluid3D([12245,11897,12062,11509],0); -ELEMENTS[69163] = Fluid3D([11897,12062,11509,10961],0); -ELEMENTS[69164] = Fluid3D([11897,12062,10961,11924],0); -ELEMENTS[69165] = Fluid3D([11897,12062,11924,12751],0); -ELEMENTS[69166] = Fluid3D([11897,12977,12062,13161],0); -ELEMENTS[69167] = Fluid3D([12062,11897,13161,12751],0); -ELEMENTS[69168] = Fluid3D([11218,10373,10191,11088],0); -ELEMENTS[69169] = Fluid3D([15556,15368,15890,15128],0); -ELEMENTS[69170] = Fluid3D([15368,15890,15128,15504],0); -ELEMENTS[69171] = Fluid3D([15556,15368,15128,14618],0); -ELEMENTS[69172] = Fluid3D([4655,4746,4195,4700],0); -ELEMENTS[69173] = Fluid3D([7483,6643,6742,6969],0); -ELEMENTS[69174] = Fluid3D([17215,16904,17422,17359],0); -ELEMENTS[69175] = Fluid3D([13976,14714,14916,13997],0); -ELEMENTS[69176] = Fluid3D([9583,10652,10156,9961],0); -ELEMENTS[69177] = Fluid3D([8606,8599,7968,8917],0); -ELEMENTS[69178] = Fluid3D([15007,14348,15360,14437],0); -ELEMENTS[69179] = Fluid3D([17752,17875,18081,17943],0); -ELEMENTS[69180] = Fluid3D([11146,10651,11537,10185],0); -ELEMENTS[69181] = Fluid3D([16372,16598,16303,16948],0); -ELEMENTS[69182] = Fluid3D([17133,17159,17211,16707],0); -ELEMENTS[69183] = Fluid3D([11339,10775,10520,10867],0); -ELEMENTS[69184] = Fluid3D([10520,11339,10867,11707],0); -ELEMENTS[69185] = Fluid3D([4863,4983,5353,5449],0); -ELEMENTS[69186] = Fluid3D([5353,4863,5449,4673],0); -ELEMENTS[69187] = Fluid3D([4983,5353,5449,5754],0); -ELEMENTS[69188] = Fluid3D([4863,4983,5449,5613],0); -ELEMENTS[69189] = Fluid3D([15067,14602,15344,14923],0); -ELEMENTS[69190] = Fluid3D([1746,1879,1931,1818],0); -ELEMENTS[69191] = Fluid3D([9885,9338,8633,8917],0); -ELEMENTS[69192] = Fluid3D([9885,9338,8917,9664],0); -ELEMENTS[69193] = Fluid3D([17706,18035,17882,17975],0); -ELEMENTS[69194] = Fluid3D([17882,17706,17975,18033],0); -ELEMENTS[69195] = Fluid3D([17039,16986,16800,17487],0); -ELEMENTS[69196] = Fluid3D([15986,16288,15878,16704],0); -ELEMENTS[69197] = Fluid3D([3725,3314,3370,3693],0); -ELEMENTS[69198] = Fluid3D([14366,14063,14422,13578],0); -ELEMENTS[69199] = Fluid3D([14763,14307,13646,14370],0); -ELEMENTS[69200] = Fluid3D([8540,8162,7898,8685],0); -ELEMENTS[69201] = Fluid3D([9697,10358,9919,9818],0); -ELEMENTS[69202] = Fluid3D([9697,10358,9818,10447],0); -ELEMENTS[69203] = Fluid3D([3226,3563,3604,3881],0); -ELEMENTS[69204] = Fluid3D([16023,15992,16602,16358],0); -ELEMENTS[69205] = Fluid3D([9329,9384,9040,10005],0); -ELEMENTS[69206] = Fluid3D([3515,3485,3203,3688],0); -ELEMENTS[69207] = Fluid3D([8629,8811,8469,7842],0); -ELEMENTS[69208] = Fluid3D([13034,13778,12813,13872],0); -ELEMENTS[69209] = Fluid3D([16347,16572,16436,16386],0); -ELEMENTS[69210] = Fluid3D([16347,16572,16386,15876],0); -ELEMENTS[69211] = Fluid3D([7704,8384,8604,8491],0); -ELEMENTS[69212] = Fluid3D([6218,5719,6113,5490],0); -ELEMENTS[69213] = Fluid3D([8104,8382,7605,7059],0); -ELEMENTS[69214] = Fluid3D([17224,16790,16712,16638],0); -ELEMENTS[69215] = Fluid3D([1846,1783,1681,1706],0); -ELEMENTS[69216] = Fluid3D([9689,9822,10001,10826],0); -ELEMENTS[69217] = Fluid3D([13917,13953,14468,14157],0); -ELEMENTS[69218] = Fluid3D([12037,11621,12803,12234],0); -ELEMENTS[69219] = Fluid3D([13642,12866,12815,13461],0); -ELEMENTS[69220] = Fluid3D([8333,8097,7569,8416],0); -ELEMENTS[69221] = Fluid3D([13066,13304,12387,12405],0); -ELEMENTS[69222] = Fluid3D([16973,17387,16848,17224],0); -ELEMENTS[69223] = Fluid3D([5572,5812,6303,5715],0); -ELEMENTS[69224] = Fluid3D([5572,5812,5715,5231],0); -ELEMENTS[69225] = Fluid3D([5812,5715,5231,5578],0); -ELEMENTS[69226] = Fluid3D([18386,18418,18498,18380],0); -ELEMENTS[69227] = Fluid3D([15425,15523,15719,15390],0); -ELEMENTS[69228] = Fluid3D([15425,15523,15390,15024],0); -ELEMENTS[69229] = Fluid3D([15559,16209,16133,15906],0); -ELEMENTS[69230] = Fluid3D([11168,10978,10357,9923],0); -ELEMENTS[69231] = Fluid3D([10357,11168,9923,10130],0); -ELEMENTS[69232] = Fluid3D([10282,9299,9941,10408],0); -ELEMENTS[69233] = Fluid3D([7990,8977,8505,8208],0); -ELEMENTS[69234] = Fluid3D([7990,8977,8208,9226],0); -ELEMENTS[69235] = Fluid3D([13804,14074,14449,13057],0); -ELEMENTS[69236] = Fluid3D([14048,13529,12837,13871],0); -ELEMENTS[69237] = Fluid3D([17931,18141,17927,18032],0); -ELEMENTS[69238] = Fluid3D([15720,15642,15703,16145],0); -ELEMENTS[69239] = Fluid3D([14670,15254,15055,14322],0); -ELEMENTS[69240] = Fluid3D([17437,17291,17380,17603],0); -ELEMENTS[69241] = Fluid3D([8194,8249,7757,7461],0); -ELEMENTS[69242] = Fluid3D([14122,13645,14599,14375],0); -ELEMENTS[69243] = Fluid3D([13563,13868,13668,12721],0); -ELEMENTS[69244] = Fluid3D([5205,5475,5545,5958],0); -ELEMENTS[69245] = Fluid3D([5545,5205,5958,5576],0); -ELEMENTS[69246] = Fluid3D([5205,5475,5958,6111],0); -ELEMENTS[69247] = Fluid3D([15112,15371,15003,14976],0); -ELEMENTS[69248] = Fluid3D([7647,7517,8090,7737],0); -ELEMENTS[69249] = Fluid3D([8090,7647,7737,8779],0); -ELEMENTS[69250] = Fluid3D([7737,8090,8779,9179],0); -ELEMENTS[69251] = Fluid3D([17554,17641,17219,17606],0); -ELEMENTS[69252] = Fluid3D([9019,8324,8596,8631],0); -ELEMENTS[69253] = Fluid3D([8791,8671,9631,9484],0); -ELEMENTS[69254] = Fluid3D([17585,17418,17274,17277],0); -ELEMENTS[69255] = Fluid3D([17274,17585,17277,17679],0); -ELEMENTS[69256] = Fluid3D([17418,17274,17277,16963],0); -ELEMENTS[69257] = Fluid3D([17274,17277,16963,16827],0); -ELEMENTS[69258] = Fluid3D([17274,17277,16827,16854],0); -ELEMENTS[69259] = Fluid3D([17274,17277,16854,17013],0); -ELEMENTS[69260] = Fluid3D([16827,17274,16854,17013],0); -ELEMENTS[69261] = Fluid3D([17274,17277,17013,17314],0); -ELEMENTS[69262] = Fluid3D([16963,17274,16827,17302],0); -ELEMENTS[69263] = Fluid3D([17274,17277,17314,17679],0); -ELEMENTS[69264] = Fluid3D([11237,11533,12193,11634],0); -ELEMENTS[69265] = Fluid3D([4998,5266,4595,4890],0); -ELEMENTS[69266] = Fluid3D([8125,7623,7167,7314],0); -ELEMENTS[69267] = Fluid3D([12624,12680,11947,12762],0); -ELEMENTS[69268] = Fluid3D([12680,11947,12762,12416],0); -ELEMENTS[69269] = Fluid3D([12680,11947,12416,11993],0); -ELEMENTS[69270] = Fluid3D([12624,12680,12762,13908],0); -ELEMENTS[69271] = Fluid3D([13012,13796,13486,12823],0); -ELEMENTS[69272] = Fluid3D([14443,14288,13676,13896],0); -ELEMENTS[69273] = Fluid3D([6193,5852,6757,6601],0); -ELEMENTS[69274] = Fluid3D([11505,11172,11658,10497],0); -ELEMENTS[69275] = Fluid3D([18355,18413,18497,18521],0); -ELEMENTS[69276] = Fluid3D([18653,18678,18625,18650],0); -ELEMENTS[69277] = Fluid3D([11312,10922,12052,11269],0); -ELEMENTS[69278] = Fluid3D([17367,17192,17109,16992],0); -ELEMENTS[69279] = Fluid3D([14588,14241,14808,14711],0); -ELEMENTS[69280] = Fluid3D([7272,8174,7326,7832],0); -ELEMENTS[69281] = Fluid3D([14102,14315,15008,14595],0); -ELEMENTS[69282] = Fluid3D([16021,16003,16316,15420],0); -ELEMENTS[69283] = Fluid3D([8748,8073,8676,8621],0); -ELEMENTS[69284] = Fluid3D([12483,11768,12152,11698],0); -ELEMENTS[69285] = Fluid3D([12483,11768,11698,11861],0); -ELEMENTS[69286] = Fluid3D([18609,18524,18600,18473],0); -ELEMENTS[69287] = Fluid3D([17420,17653,17788,17458],0); -ELEMENTS[69288] = Fluid3D([17420,17653,17458,17592],0); -ELEMENTS[69289] = Fluid3D([17653,17458,17592,17701],0); -ELEMENTS[69290] = Fluid3D([17653,17788,17458,17701],0); -ELEMENTS[69291] = Fluid3D([17788,17458,17701,17364],0); -ELEMENTS[69292] = Fluid3D([17458,17701,17364,17269],0); -ELEMENTS[69293] = Fluid3D([17788,17458,17364,17420],0); -ELEMENTS[69294] = Fluid3D([17458,17364,17420,17085],0); -ELEMENTS[69295] = Fluid3D([17458,17364,17085,17269],0); -ELEMENTS[69296] = Fluid3D([17420,17458,17085,17329],0); -ELEMENTS[69297] = Fluid3D([17458,17085,17329,17269],0); -ELEMENTS[69298] = Fluid3D([14642,14707,13759,13597],0); -ELEMENTS[69299] = Fluid3D([5277,5251,5124,4536],0); -ELEMENTS[69300] = Fluid3D([17686,17461,17131,17442],0); -ELEMENTS[69301] = Fluid3D([17461,17131,17442,17519],0); -ELEMENTS[69302] = Fluid3D([17686,17461,17442,17735],0); -ELEMENTS[69303] = Fluid3D([13863,14564,13626,13799],0); -ELEMENTS[69304] = Fluid3D([5802,5891,5975,6650],0); -ELEMENTS[69305] = Fluid3D([6412,7143,6462,6938],0); -ELEMENTS[69306] = Fluid3D([15014,15006,14360,14856],0); -ELEMENTS[69307] = Fluid3D([2860,2572,2680,2963],0); -ELEMENTS[69308] = Fluid3D([5687,5285,5648,6112],0); -ELEMENTS[69309] = Fluid3D([13303,13687,13048,13252],0); -ELEMENTS[69310] = Fluid3D([5784,6187,6062,5347],0); -ELEMENTS[69311] = Fluid3D([6444,6656,7477,6886],0); -ELEMENTS[69312] = Fluid3D([10831,10720,11474,11423],0); -ELEMENTS[69313] = Fluid3D([6710,6193,6090,6234],0); -ELEMENTS[69314] = Fluid3D([13342,12903,12605,11795],0); -ELEMENTS[69315] = Fluid3D([12432,12718,13440,13768],0); -ELEMENTS[69316] = Fluid3D([9943,9386,10371,10266],0); -ELEMENTS[69317] = Fluid3D([18488,18490,18500,18346],0); -ELEMENTS[69318] = Fluid3D([16174,16316,16003,15420],0); -ELEMENTS[69319] = Fluid3D([6987,6362,6387,5783],0); -ELEMENTS[69320] = Fluid3D([10637,11635,10976,11045],0); -ELEMENTS[69321] = Fluid3D([11635,10976,11045,12179],0); -ELEMENTS[69322] = Fluid3D([12706,12088,12884,13215],0); -ELEMENTS[69323] = Fluid3D([17483,17622,17303,17011],0); -ELEMENTS[69324] = Fluid3D([9596,10308,10227,9861],0); -ELEMENTS[69325] = Fluid3D([14454,13506,14354,14421],0); -ELEMENTS[69326] = Fluid3D([16040,15576,15267,15462],0); -ELEMENTS[69327] = Fluid3D([14863,15683,14938,15313],0); -ELEMENTS[69328] = Fluid3D([15683,14938,15313,15545],0); -ELEMENTS[69329] = Fluid3D([14938,15313,15545,14802],0); -ELEMENTS[69330] = Fluid3D([14938,15313,14802,14960],0); -ELEMENTS[69331] = Fluid3D([12732,12730,13707,13334],0); -ELEMENTS[69332] = Fluid3D([7836,8737,8585,8891],0); -ELEMENTS[69333] = Fluid3D([8737,8585,8891,9773],0); -ELEMENTS[69334] = Fluid3D([8585,8891,9773,9293],0); -ELEMENTS[69335] = Fluid3D([8585,8891,9293,9064],0); -ELEMENTS[69336] = Fluid3D([8585,7836,8891,7538],0); -ELEMENTS[69337] = Fluid3D([8585,7836,7538,8692],0); -ELEMENTS[69338] = Fluid3D([8891,8585,7538,8439],0); -ELEMENTS[69339] = Fluid3D([8891,8585,8439,9064],0); -ELEMENTS[69340] = Fluid3D([7726,8296,7501,7213],0); -ELEMENTS[69341] = Fluid3D([14267,14544,15288,14243],0); -ELEMENTS[69342] = Fluid3D([14267,14544,14243,13461],0); -ELEMENTS[69343] = Fluid3D([14243,14267,13461,13615],0); -ELEMENTS[69344] = Fluid3D([14267,14544,13461,13642],0); -ELEMENTS[69345] = Fluid3D([18481,18370,18344,18543],0); -ELEMENTS[69346] = Fluid3D([4924,5097,4727,4994],0); -ELEMENTS[69347] = Fluid3D([17966,17803,17688,17509],0); -ELEMENTS[69348] = Fluid3D([17966,17803,17509,17793],0); -ELEMENTS[69349] = Fluid3D([15348,14773,14847,14710],0); -ELEMENTS[69350] = Fluid3D([3019,2725,3077,2772],0); -ELEMENTS[69351] = Fluid3D([14559,14290,15134,15339],0); -ELEMENTS[69352] = Fluid3D([18257,18377,18466,18476],0); -ELEMENTS[69353] = Fluid3D([6494,6943,7262,7425],0); -ELEMENTS[69354] = Fluid3D([11030,10271,10830,10725],0); -ELEMENTS[69355] = Fluid3D([8078,7789,8347,8803],0); -ELEMENTS[69356] = Fluid3D([8347,8078,8803,8979],0); -ELEMENTS[69357] = Fluid3D([4592,5077,5100,5143],0); -ELEMENTS[69358] = Fluid3D([4592,5077,5143,4486],0); -ELEMENTS[69359] = Fluid3D([9357,10079,9516,10145],0); -ELEMENTS[69360] = Fluid3D([3112,3308,3053,2926],0); -ELEMENTS[69361] = Fluid3D([3112,3308,2926,3339],0); -ELEMENTS[69362] = Fluid3D([2926,3112,3339,3062],0); -ELEMENTS[69363] = Fluid3D([3179,3261,3450,3600],0); -ELEMENTS[69364] = Fluid3D([13352,12963,13057,14074],0); -ELEMENTS[69365] = Fluid3D([13518,13699,12626,13276],0); -ELEMENTS[69366] = Fluid3D([9274,9323,10432,10474],0); -ELEMENTS[69367] = Fluid3D([4658,4509,4290,4859],0); -ELEMENTS[69368] = Fluid3D([8902,8137,8370,8651],0); -ELEMENTS[69369] = Fluid3D([2282,2240,2512,2410],0); -ELEMENTS[69370] = Fluid3D([14934,14994,15261,15739],0); -ELEMENTS[69371] = Fluid3D([15677,16260,15992,16429],0); -ELEMENTS[69372] = Fluid3D([5458,5701,6231,5686],0); -ELEMENTS[69373] = Fluid3D([17660,17808,17983,18120],0); -ELEMENTS[69374] = Fluid3D([2146,2197,2250,1985],0); -ELEMENTS[69375] = Fluid3D([2146,2197,1985,1969],0); -ELEMENTS[69376] = Fluid3D([3334,3057,3037,3411],0); -ELEMENTS[69377] = Fluid3D([4116,4351,4296,4767],0); -ELEMENTS[69378] = Fluid3D([4116,4351,4767,4569],0); -ELEMENTS[69379] = Fluid3D([11876,12550,11220,12037],0); -ELEMENTS[69380] = Fluid3D([13634,13750,14066,14312],0); -ELEMENTS[69381] = Fluid3D([11509,12062,11520,10961],0); -ELEMENTS[69382] = Fluid3D([13775,14321,13637,13783],0); -ELEMENTS[69383] = Fluid3D([18484,18328,18434,18472],0); -ELEMENTS[69384] = Fluid3D([18434,18484,18472,18591],0); -ELEMENTS[69385] = Fluid3D([2237,2108,1941,2220],0); -ELEMENTS[69386] = Fluid3D([10551,10170,10089,11229],0); -ELEMENTS[69387] = Fluid3D([3795,4305,4015,3780],0); -ELEMENTS[69388] = Fluid3D([4893,4745,4280,4429],0); -ELEMENTS[69389] = Fluid3D([14550,14562,15255,15433],0); -ELEMENTS[69390] = Fluid3D([18051,18171,18263,18110],0); -ELEMENTS[69391] = Fluid3D([15674,15147,15558,15188],0); -ELEMENTS[69392] = Fluid3D([12763,13179,13433,12298],0); -ELEMENTS[69393] = Fluid3D([12763,13179,12298,12527],0); -ELEMENTS[69394] = Fluid3D([12763,13179,12527,12478],0); -ELEMENTS[69395] = Fluid3D([17986,17924,17779,17536],0); -ELEMENTS[69396] = Fluid3D([17713,17682,17583,17226],0); -ELEMENTS[69397] = Fluid3D([14717,14476,14262,13699],0); -ELEMENTS[69398] = Fluid3D([10346,9990,9368,9364],0); -ELEMENTS[69399] = Fluid3D([10346,9990,9364,9702],0); -ELEMENTS[69400] = Fluid3D([9364,10346,9702,9097],0); -ELEMENTS[69401] = Fluid3D([9702,9364,9097,8794],0); -ELEMENTS[69402] = Fluid3D([9702,9364,8794,9440],0); -ELEMENTS[69403] = Fluid3D([9364,8794,9440,9990],0); -ELEMENTS[69404] = Fluid3D([9364,9097,8794,8478],0); -ELEMENTS[69405] = Fluid3D([8794,9364,8478,9368],0); -ELEMENTS[69406] = Fluid3D([9364,9097,8478,9368],0); -ELEMENTS[69407] = Fluid3D([9364,8794,9990,9368],0); -ELEMENTS[69408] = Fluid3D([9440,9364,9990,9702],0); -ELEMENTS[69409] = Fluid3D([9364,9097,9368,10346],0); -ELEMENTS[69410] = Fluid3D([12203,11256,11668,11391],0); -ELEMENTS[69411] = Fluid3D([4385,4905,4405,5038],0); -ELEMENTS[69412] = Fluid3D([16564,16584,16509,15865],0); -ELEMENTS[69413] = Fluid3D([13196,13626,12633,12961],0); -ELEMENTS[69414] = Fluid3D([16657,16470,16332,15851],0); -ELEMENTS[69415] = Fluid3D([14503,14766,15070,14619],0); -ELEMENTS[69416] = Fluid3D([16010,16588,16068,16194],0); -ELEMENTS[69417] = Fluid3D([8595,9290,9240,10209],0); -ELEMENTS[69418] = Fluid3D([11316,12165,11495,11727],0); -ELEMENTS[69419] = Fluid3D([11316,12165,11727,11051],0); -ELEMENTS[69420] = Fluid3D([12165,11727,11051,12074],0); -ELEMENTS[69421] = Fluid3D([12165,11727,12074,12281],0); -ELEMENTS[69422] = Fluid3D([12165,11727,12281,11495],0); -ELEMENTS[69423] = Fluid3D([11727,12074,12281,11497],0); -ELEMENTS[69424] = Fluid3D([12281,11727,11497,10948],0); -ELEMENTS[69425] = Fluid3D([11727,11497,10948,12074],0); -ELEMENTS[69426] = Fluid3D([12281,11727,10948,11198],0); -ELEMENTS[69427] = Fluid3D([11727,10948,11198,11316],0); -ELEMENTS[69428] = Fluid3D([11497,12281,10948,11470],0); -ELEMENTS[69429] = Fluid3D([10948,11497,11470,10750],0); -ELEMENTS[69430] = Fluid3D([10948,11497,10750,10814],0); -ELEMENTS[69431] = Fluid3D([10948,11497,10814,12074],0); -ELEMENTS[69432] = Fluid3D([11497,11470,10750,12107],0); -ELEMENTS[69433] = Fluid3D([11497,10750,10814,11298],0); -ELEMENTS[69434] = Fluid3D([11727,11316,11051,10948],0); -ELEMENTS[69435] = Fluid3D([11051,11727,10948,12074],0); -ELEMENTS[69436] = Fluid3D([12074,12281,11497,12107],0); -ELEMENTS[69437] = Fluid3D([11497,12074,12107,10814],0); -ELEMENTS[69438] = Fluid3D([11497,12281,11470,12107],0); -ELEMENTS[69439] = Fluid3D([12281,11727,11198,11495],0); -ELEMENTS[69440] = Fluid3D([11727,11198,11495,11316],0); -ELEMENTS[69441] = Fluid3D([14659,15176,15235,15242],0); -ELEMENTS[69442] = Fluid3D([4719,5313,5613,4963],0); -ELEMENTS[69443] = Fluid3D([14886,15180,15666,15467],0); -ELEMENTS[69444] = Fluid3D([9191,8505,8429,8323],0); -ELEMENTS[69445] = Fluid3D([9191,8505,8323,8770],0); -ELEMENTS[69446] = Fluid3D([8505,8323,8770,7818],0); -ELEMENTS[69447] = Fluid3D([15534,15781,15923,16223],0); -ELEMENTS[69448] = Fluid3D([15923,15534,16223,15723],0); -ELEMENTS[69449] = Fluid3D([15534,16223,15723,15287],0); -ELEMENTS[69450] = Fluid3D([15723,15534,15287,15397],0); -ELEMENTS[69451] = Fluid3D([15723,15534,15397,15923],0); -ELEMENTS[69452] = Fluid3D([15534,15397,15923,15620],0); -ELEMENTS[69453] = Fluid3D([9812,9986,9192,10543],0); -ELEMENTS[69454] = Fluid3D([17271,17464,17646,17154],0); -ELEMENTS[69455] = Fluid3D([16441,16706,16405,15971],0); -ELEMENTS[69456] = Fluid3D([17303,17221,17622,17602],0); -ELEMENTS[69457] = Fluid3D([5626,5093,5765,5897],0); -ELEMENTS[69458] = Fluid3D([17032,16800,16986,17487],0); -ELEMENTS[69459] = Fluid3D([16782,16554,17143,16944],0); -ELEMENTS[69460] = Fluid3D([12507,13225,12057,12147],0); -ELEMENTS[69461] = Fluid3D([13302,13596,12678,12802],0); -ELEMENTS[69462] = Fluid3D([5017,5093,4750,5261],0); -ELEMENTS[69463] = Fluid3D([8428,8543,8305,9247],0); -ELEMENTS[69464] = Fluid3D([15885,15676,15239,16154],0); -ELEMENTS[69465] = Fluid3D([15885,15676,16154,16470],0); -ELEMENTS[69466] = Fluid3D([16154,15885,16470,16442],0); -ELEMENTS[69467] = Fluid3D([18391,18169,18433,18365],0); -ELEMENTS[69468] = Fluid3D([17895,18157,17863,18075],0); -ELEMENTS[69469] = Fluid3D([10908,11211,11888,11256],0); -ELEMENTS[69470] = Fluid3D([16750,16371,16898,16667],0); -ELEMENTS[69471] = Fluid3D([16750,16371,16667,16106],0); -ELEMENTS[69472] = Fluid3D([16812,17139,17115,17347],0); -ELEMENTS[69473] = Fluid3D([6898,7152,7733,6479],0); -ELEMENTS[69474] = Fluid3D([14637,15236,14856,15549],0); -ELEMENTS[69475] = Fluid3D([17364,17098,17210,17420],0); -ELEMENTS[69476] = Fluid3D([2770,2742,2718,2493],0); -ELEMENTS[69477] = Fluid3D([16513,16947,16369,16977],0); -ELEMENTS[69478] = Fluid3D([5372,5884,5645,5322],0); -ELEMENTS[69479] = Fluid3D([13755,14419,13733,13746],0); -ELEMENTS[69480] = Fluid3D([18305,18414,18495,18354],0); -ELEMENTS[69481] = Fluid3D([4832,5272,4774,4753],0); -ELEMENTS[69482] = Fluid3D([3778,4272,3897,4150],0); -ELEMENTS[69483] = Fluid3D([3420,3064,3223,3351],0); -ELEMENTS[69484] = Fluid3D([1625,1744,1613,1759],0); -ELEMENTS[69485] = Fluid3D([7932,8662,8508,8906],0); -ELEMENTS[69486] = Fluid3D([9157,8863,9352,10061],0); -ELEMENTS[69487] = Fluid3D([5124,4708,5277,4536],0); -ELEMENTS[69488] = Fluid3D([14722,14157,15056,14837],0); -ELEMENTS[69489] = Fluid3D([5642,5998,6463,6093],0); -ELEMENTS[69490] = Fluid3D([10437,11446,10732,10619],0); -ELEMENTS[69491] = Fluid3D([13644,13462,12753,12784],0); -ELEMENTS[69492] = Fluid3D([9779,9828,9421,8976],0); -ELEMENTS[69493] = Fluid3D([9779,9828,8976,9461],0); -ELEMENTS[69494] = Fluid3D([8976,9779,9461,9206],0); -ELEMENTS[69495] = Fluid3D([6012,5658,5381,5700],0); -ELEMENTS[69496] = Fluid3D([7294,7471,6653,6924],0); -ELEMENTS[69497] = Fluid3D([14198,13607,14550,13817],0); -ELEMENTS[69498] = Fluid3D([18572,18588,18645,18626],0); -ELEMENTS[69499] = Fluid3D([14321,14604,13637,14379],0); -ELEMENTS[69500] = Fluid3D([10469,10891,11868,11310],0); -ELEMENTS[69501] = Fluid3D([4081,3852,3888,3476],0); -ELEMENTS[69502] = Fluid3D([13440,13738,12432,13310],0); -ELEMENTS[69503] = Fluid3D([16921,16697,17293,17031],0); -ELEMENTS[69504] = Fluid3D([16400,16064,16451,16121],0); -ELEMENTS[69505] = Fluid3D([2843,2593,2910,2820],0); -ELEMENTS[69506] = Fluid3D([2843,2593,2820,2932],0); -ELEMENTS[69507] = Fluid3D([6352,6286,5822,7132],0); -ELEMENTS[69508] = Fluid3D([7109,6715,7780,6939],0); -ELEMENTS[69509] = Fluid3D([5654,6168,5976,5772],0); -ELEMENTS[69510] = Fluid3D([7537,7427,8137,8370],0); -ELEMENTS[69511] = Fluid3D([10146,9799,9885,10264],0); -ELEMENTS[69512] = Fluid3D([5676,5812,5231,5426],0); -ELEMENTS[69513] = Fluid3D([5812,5231,5426,5578],0); -ELEMENTS[69514] = Fluid3D([15001,14992,14296,14072],0); -ELEMENTS[69515] = Fluid3D([15543,15303,14885,15451],0); -ELEMENTS[69516] = Fluid3D([6083,5573,5611,5234],0); -ELEMENTS[69517] = Fluid3D([15277,14799,14507,14851],0); -ELEMENTS[69518] = Fluid3D([18079,18037,17838,18092],0); -ELEMENTS[69519] = Fluid3D([5478,5522,6152,5603],0); -ELEMENTS[69520] = Fluid3D([15250,15054,15774,15345],0); -ELEMENTS[69521] = Fluid3D([12387,11439,11986,11992],0); -ELEMENTS[69522] = Fluid3D([16194,15653,15900,15550],0); -ELEMENTS[69523] = Fluid3D([15653,15900,15550,15145],0); -ELEMENTS[69524] = Fluid3D([7995,8488,8574,7917],0); -ELEMENTS[69525] = Fluid3D([13297,13711,14382,13807],0); -ELEMENTS[69526] = Fluid3D([2746,2546,2774,3108],0); -ELEMENTS[69527] = Fluid3D([17867,17929,17648,17792],0); -ELEMENTS[69528] = Fluid3D([17929,17648,17792,17705],0); -ELEMENTS[69529] = Fluid3D([17648,17867,17792,18068],0); -ELEMENTS[69530] = Fluid3D([17648,17792,17705,17460],0); -ELEMENTS[69531] = Fluid3D([17648,17792,17460,17781],0); -ELEMENTS[69532] = Fluid3D([5726,5851,5002,5743],0); -ELEMENTS[69533] = Fluid3D([5726,5851,5743,6219],0); -ELEMENTS[69534] = Fluid3D([11405,11068,12207,11365],0); -ELEMENTS[69535] = Fluid3D([11405,11068,11365,9917],0); -ELEMENTS[69536] = Fluid3D([17527,17229,17628,17621],0); -ELEMENTS[69537] = Fluid3D([12237,11728,12438,12979],0); -ELEMENTS[69538] = Fluid3D([4326,4348,4154,4639],0); -ELEMENTS[69539] = Fluid3D([4089,3609,3548,3845],0); -ELEMENTS[69540] = Fluid3D([10213,9317,10010,9682],0); -ELEMENTS[69541] = Fluid3D([10010,10213,9682,10680],0); -ELEMENTS[69542] = Fluid3D([5535,5685,4930,5195],0); -ELEMENTS[69543] = Fluid3D([16966,17169,16732,16948],0); -ELEMENTS[69544] = Fluid3D([18333,18380,18451,18391],0); -ELEMENTS[69545] = Fluid3D([18380,18451,18391,18503],0); -ELEMENTS[69546] = Fluid3D([18451,18391,18503,18430],0); -ELEMENTS[69547] = Fluid3D([18391,18503,18430,18365],0); -ELEMENTS[69548] = Fluid3D([18503,18430,18365,18441],0); -ELEMENTS[69549] = Fluid3D([18430,18365,18441,18241],0); -ELEMENTS[69550] = Fluid3D([18503,18430,18441,18451],0); -ELEMENTS[69551] = Fluid3D([18430,18365,18241,18391],0); -ELEMENTS[69552] = Fluid3D([18430,18441,18451,18241],0); -ELEMENTS[69553] = Fluid3D([18451,18391,18430,18241],0); -ELEMENTS[69554] = Fluid3D([15629,15274,15957,15434],0); -ELEMENTS[69555] = Fluid3D([6530,6873,7299,6504],0); -ELEMENTS[69556] = Fluid3D([6873,7299,6504,6396],0); -ELEMENTS[69557] = Fluid3D([5518,6137,6004,5573],0); -ELEMENTS[69558] = Fluid3D([5518,6137,5573,5611],0); -ELEMENTS[69559] = Fluid3D([3142,3430,3209,2888],0); -ELEMENTS[69560] = Fluid3D([18004,17782,17616,17720],0); -ELEMENTS[69561] = Fluid3D([7554,6694,7217,7027],0); -ELEMENTS[69562] = Fluid3D([15812,15819,15800,16169],0); -ELEMENTS[69563] = Fluid3D([13030,13271,12128,12813],0); -ELEMENTS[69564] = Fluid3D([10051,9216,10659,9589],0); -ELEMENTS[69565] = Fluid3D([9686,9236,10221,9601],0); -ELEMENTS[69566] = Fluid3D([9686,9236,9601,8475],0); -ELEMENTS[69567] = Fluid3D([3019,3026,3392,3497],0); -ELEMENTS[69568] = Fluid3D([16963,16525,17172,17130],0); -ELEMENTS[69569] = Fluid3D([17172,16963,17130,17277],0); -ELEMENTS[69570] = Fluid3D([16963,16525,17130,16381],0); -ELEMENTS[69571] = Fluid3D([16525,17172,17130,16965],0); -ELEMENTS[69572] = Fluid3D([17130,17172,17277,17698],0); -ELEMENTS[69573] = Fluid3D([17172,17130,16965,17538],0); -ELEMENTS[69574] = Fluid3D([17172,17130,17538,17698],0); -ELEMENTS[69575] = Fluid3D([17130,16525,16965,16381],0); -ELEMENTS[69576] = Fluid3D([7972,7692,6751,7062],0); -ELEMENTS[69577] = Fluid3D([2419,2386,2379,2062],0); -ELEMENTS[69578] = Fluid3D([16122,16280,15541,15977],0); -ELEMENTS[69579] = Fluid3D([13609,13957,13081,13555],0); -ELEMENTS[69580] = Fluid3D([17312,17682,17307,17226],0); -ELEMENTS[69581] = Fluid3D([9132,8722,9259,9701],0); -ELEMENTS[69582] = Fluid3D([11602,11977,12430,12857],0); -ELEMENTS[69583] = Fluid3D([17407,17288,17312,17730],0); -ELEMENTS[69584] = Fluid3D([2914,3330,3319,3246],0); -ELEMENTS[69585] = Fluid3D([10377,10776,10705,9788],0); -ELEMENTS[69586] = Fluid3D([10377,10776,9788,10215],0); -ELEMENTS[69587] = Fluid3D([8091,7750,7514,7141],0); -ELEMENTS[69588] = Fluid3D([13205,13861,14322,14140],0); -ELEMENTS[69589] = Fluid3D([14900,14606,15290,15433],0); -ELEMENTS[69590] = Fluid3D([16325,16117,16121,16516],0); -ELEMENTS[69591] = Fluid3D([7422,6542,7186,7453],0); -ELEMENTS[69592] = Fluid3D([13694,14020,14646,14386],0); -ELEMENTS[69593] = Fluid3D([10273,10433,11136,11558],0); -ELEMENTS[69594] = Fluid3D([11152,11993,10893,11515],0); -ELEMENTS[69595] = Fluid3D([11152,11993,11515,12143],0); -ELEMENTS[69596] = Fluid3D([17066,17082,16614,16853],0); -ELEMENTS[69597] = Fluid3D([17066,17082,16853,17173],0); -ELEMENTS[69598] = Fluid3D([15193,15770,15502,15386],0); -ELEMENTS[69599] = Fluid3D([12442,13027,12394,11909],0); -ELEMENTS[69600] = Fluid3D([4907,4999,5571,5611],0); -ELEMENTS[69601] = Fluid3D([17924,17656,17779,17536],0); -ELEMENTS[69602] = Fluid3D([6669,6957,6066,6372],0); -ELEMENTS[69603] = Fluid3D([4668,4683,4801,4463],0); -ELEMENTS[69604] = Fluid3D([5996,5915,5316,5615],0); -ELEMENTS[69605] = Fluid3D([10838,10308,10871,11845],0); -ELEMENTS[69606] = Fluid3D([15994,15938,15772,16064],0); -ELEMENTS[69607] = Fluid3D([5887,6736,6076,6259],0); -ELEMENTS[69608] = Fluid3D([7244,7253,6443,6180],0); -ELEMENTS[69609] = Fluid3D([8898,9383,8507,8614],0); -ELEMENTS[69610] = Fluid3D([12101,11045,11698,11855],0); -ELEMENTS[69611] = Fluid3D([4473,4750,4849,5152],0); -ELEMENTS[69612] = Fluid3D([14421,14432,13784,14413],0); -ELEMENTS[69613] = Fluid3D([9660,10504,10400,10376],0); -ELEMENTS[69614] = Fluid3D([10504,10400,10376,11488],0); -ELEMENTS[69615] = Fluid3D([10400,10376,11488,11244],0); -ELEMENTS[69616] = Fluid3D([18438,18465,18288,18397],0); -ELEMENTS[69617] = Fluid3D([12463,12965,12300,11385],0); -ELEMENTS[69618] = Fluid3D([14941,15390,14499,14859],0); -ELEMENTS[69619] = Fluid3D([13211,12707,11946,12255],0); -ELEMENTS[69620] = Fluid3D([7149,7262,7425,6626],0); -ELEMENTS[69621] = Fluid3D([7262,7425,6626,6494],0); -ELEMENTS[69622] = Fluid3D([16738,16384,16612,16931],0); -ELEMENTS[69623] = Fluid3D([16738,16384,16931,16434],0); -ELEMENTS[69624] = Fluid3D([16931,16738,16434,16781],0); -ELEMENTS[69625] = Fluid3D([4976,5059,4839,4506],0); -ELEMENTS[69626] = Fluid3D([18231,17879,18127,17840],0); -ELEMENTS[69627] = Fluid3D([15804,15225,16039,15723],0); -ELEMENTS[69628] = Fluid3D([4814,4929,4949,5543],0); -ELEMENTS[69629] = Fluid3D([6331,5957,6121,5527],0); -ELEMENTS[69630] = Fluid3D([14851,14507,14255,14799],0); -ELEMENTS[69631] = Fluid3D([7428,7507,8453,7519],0); -ELEMENTS[69632] = Fluid3D([10819,9980,10755,9690],0); -ELEMENTS[69633] = Fluid3D([16099,16614,16436,16852],0); -ELEMENTS[69634] = Fluid3D([6164,6873,6530,6504],0); -ELEMENTS[69635] = Fluid3D([2610,2577,2932,3074],0); -ELEMENTS[69636] = Fluid3D([5108,4542,4490,4811],0); -ELEMENTS[69637] = Fluid3D([12981,13657,13825,12745],0); -ELEMENTS[69638] = Fluid3D([10955,9734,10360,9927],0); -ELEMENTS[69639] = Fluid3D([14823,15283,14513,14027],0); -ELEMENTS[69640] = Fluid3D([8672,8859,8029,8684],0); -ELEMENTS[69641] = Fluid3D([6898,6301,6479,6184],0); -ELEMENTS[69642] = Fluid3D([16158,16676,16503,16374],0); -ELEMENTS[69643] = Fluid3D([16503,16158,16374,15934],0); -ELEMENTS[69644] = Fluid3D([17517,17607,17105,17317],0); -ELEMENTS[69645] = Fluid3D([13473,13144,14170,13421],0); -ELEMENTS[69646] = Fluid3D([17002,17352,16960,17177],0); -ELEMENTS[69647] = Fluid3D([9448,9451,9715,8325],0); -ELEMENTS[69648] = Fluid3D([12706,13248,13734,13256],0); -ELEMENTS[69649] = Fluid3D([2047,2147,1933,2179],0); -ELEMENTS[69650] = Fluid3D([2047,2147,2179,2301],0); -ELEMENTS[69651] = Fluid3D([2147,2179,2301,2381],0); -ELEMENTS[69652] = Fluid3D([5524,5993,5530,5118],0); -ELEMENTS[69653] = Fluid3D([8323,8882,8379,8161],0); -ELEMENTS[69654] = Fluid3D([13207,13637,12891,12227],0); -ELEMENTS[69655] = Fluid3D([7493,7849,8506,8075],0); -ELEMENTS[69656] = Fluid3D([7493,7849,8075,7360],0); -ELEMENTS[69657] = Fluid3D([7849,8075,7360,8794],0); -ELEMENTS[69658] = Fluid3D([7849,8075,8794,9074],0); -ELEMENTS[69659] = Fluid3D([6729,6103,6204,6198],0); -ELEMENTS[69660] = Fluid3D([5659,6219,5589,5726],0); -ELEMENTS[69661] = Fluid3D([5589,5659,5726,5100],0); -ELEMENTS[69662] = Fluid3D([14620,14268,14906,13780],0); -ELEMENTS[69663] = Fluid3D([3206,3237,2872,3129],0); -ELEMENTS[69664] = Fluid3D([6956,7134,6321,6342],0); -ELEMENTS[69665] = Fluid3D([7134,6321,6342,7016],0); -ELEMENTS[69666] = Fluid3D([6956,7134,6342,6442],0); -ELEMENTS[69667] = Fluid3D([6342,7134,7016,6437],0); -ELEMENTS[69668] = Fluid3D([7134,6342,6442,7285],0); -ELEMENTS[69669] = Fluid3D([7134,6342,7285,6437],0); -ELEMENTS[69670] = Fluid3D([6321,6956,6342,6442],0); -ELEMENTS[69671] = Fluid3D([17230,16835,17048,17234],0); -ELEMENTS[69672] = Fluid3D([11702,11401,11692,12845],0); -ELEMENTS[69673] = Fluid3D([12827,12557,13090,12617],0); -ELEMENTS[69674] = Fluid3D([13090,12827,12617,13931],0); -ELEMENTS[69675] = Fluid3D([15083,15490,15539,15930],0); -ELEMENTS[69676] = Fluid3D([5026,4555,4441,4279],0); -ELEMENTS[69677] = Fluid3D([15724,15728,15319,14881],0); -ELEMENTS[69678] = Fluid3D([14429,15227,14627,15102],0); -ELEMENTS[69679] = Fluid3D([7142,7427,7042,7657],0); -ELEMENTS[69680] = Fluid3D([7584,7117,7260,6538],0); -ELEMENTS[69681] = Fluid3D([3253,3578,3765,3458],0); -ELEMENTS[69682] = Fluid3D([17423,17144,16810,17003],0); -ELEMENTS[69683] = Fluid3D([15979,16543,16710,16453],0); -ELEMENTS[69684] = Fluid3D([16543,16710,16453,16730],0); -ELEMENTS[69685] = Fluid3D([7882,8192,8752,7603],0); -ELEMENTS[69686] = Fluid3D([5713,6180,6140,5479],0); -ELEMENTS[69687] = Fluid3D([5713,6180,5479,5880],0); -ELEMENTS[69688] = Fluid3D([1546,1610,1664,1671],0); -ELEMENTS[69689] = Fluid3D([1610,1664,1671,1759],0); -ELEMENTS[69690] = Fluid3D([1664,1671,1759,1613],0); -ELEMENTS[69691] = Fluid3D([1671,1759,1613,1746],0); -ELEMENTS[69692] = Fluid3D([1671,1610,1759,1693],0); -ELEMENTS[69693] = Fluid3D([1546,1610,1671,1618],0); -ELEMENTS[69694] = Fluid3D([1610,1664,1759,1698],0); -ELEMENTS[69695] = Fluid3D([1664,1671,1613,1546],0); -ELEMENTS[69696] = Fluid3D([1671,1613,1546,1543],0); -ELEMENTS[69697] = Fluid3D([1671,1610,1693,1618],0); -ELEMENTS[69698] = Fluid3D([5845,5684,5600,6172],0); -ELEMENTS[69699] = Fluid3D([7022,6746,7593,6987],0); -ELEMENTS[69700] = Fluid3D([10689,10815,11942,11781],0); -ELEMENTS[69701] = Fluid3D([3142,3132,2826,3209],0); -ELEMENTS[69702] = Fluid3D([9531,9609,9811,8759],0); -ELEMENTS[69703] = Fluid3D([4890,4410,4595,4998],0); -ELEMENTS[69704] = Fluid3D([4600,4578,5178,4718],0); -ELEMENTS[69705] = Fluid3D([10184,9661,9387,8792],0); -ELEMENTS[69706] = Fluid3D([18518,18614,18629,18628],0); -ELEMENTS[69707] = Fluid3D([18614,18629,18628,18643],0); -ELEMENTS[69708] = Fluid3D([18628,18614,18643,18518],0); -ELEMENTS[69709] = Fluid3D([8149,8288,8520,8043],0); -ELEMENTS[69710] = Fluid3D([12435,11868,13020,12519],0); -ELEMENTS[69711] = Fluid3D([11044,10921,10826,11688],0); -ELEMENTS[69712] = Fluid3D([10921,10826,11688,10429],0); -ELEMENTS[69713] = Fluid3D([11044,10921,11688,11815],0); -ELEMENTS[69714] = Fluid3D([10921,11688,11815,10429],0); -ELEMENTS[69715] = Fluid3D([7034,6248,6126,6320],0); -ELEMENTS[69716] = Fluid3D([12311,13198,12925,13616],0); -ELEMENTS[69717] = Fluid3D([14834,14181,13940,13740],0); -ELEMENTS[69718] = Fluid3D([7841,8157,8913,8749],0); -ELEMENTS[69719] = Fluid3D([17387,17428,17401,16805],0); -ELEMENTS[69720] = Fluid3D([4887,5144,5560,4891],0); -ELEMENTS[69721] = Fluid3D([6641,5986,6366,5950],0); -ELEMENTS[69722] = Fluid3D([4769,5564,5220,5174],0); -ELEMENTS[69723] = Fluid3D([15438,15121,15100,15606],0); -ELEMENTS[69724] = Fluid3D([7895,8962,8192,8470],0); -ELEMENTS[69725] = Fluid3D([11443,11175,10269,11391],0); -ELEMENTS[69726] = Fluid3D([9505,9264,9051,9696],0); -ELEMENTS[69727] = Fluid3D([14722,14185,14157,14403],0); -ELEMENTS[69728] = Fluid3D([13678,12936,12823,13977],0); -ELEMENTS[69729] = Fluid3D([16752,16903,16383,16814],0); -ELEMENTS[69730] = Fluid3D([5345,5422,5206,5778],0); -ELEMENTS[69731] = Fluid3D([5345,5422,5778,6008],0); -ELEMENTS[69732] = Fluid3D([5345,5422,6008,5610],0); -ELEMENTS[69733] = Fluid3D([14584,14329,13697,14551],0); -ELEMENTS[69734] = Fluid3D([11834,11847,11278,10552],0); -ELEMENTS[69735] = Fluid3D([9551,10027,10586,9974],0); -ELEMENTS[69736] = Fluid3D([8233,8751,9268,9001],0); -ELEMENTS[69737] = Fluid3D([17218,17065,17487,17039],0); -ELEMENTS[69738] = Fluid3D([9792,10114,8788,9616],0); -ELEMENTS[69739] = Fluid3D([13505,14417,14202,13629],0); -ELEMENTS[69740] = Fluid3D([14202,13505,13629,13353],0); -ELEMENTS[69741] = Fluid3D([13629,14202,13353,14446],0); -ELEMENTS[69742] = Fluid3D([13629,14202,14446,14453],0); -ELEMENTS[69743] = Fluid3D([13629,14202,14453,14417],0); -ELEMENTS[69744] = Fluid3D([14202,14453,14417,14975],0); -ELEMENTS[69745] = Fluid3D([2220,2318,2471,2365],0); -ELEMENTS[69746] = Fluid3D([12057,11130,11447,11423],0); -ELEMENTS[69747] = Fluid3D([18438,18324,18288,18222],0); -ELEMENTS[69748] = Fluid3D([17879,17626,17986,17845],0); -ELEMENTS[69749] = Fluid3D([17986,17879,17845,17825],0); -ELEMENTS[69750] = Fluid3D([17845,17986,17825,18167],0); -ELEMENTS[69751] = Fluid3D([12394,12612,12062,13052],0); -ELEMENTS[69752] = Fluid3D([10276,10640,9593,10076],0); -ELEMENTS[69753] = Fluid3D([14360,13972,13408,14086],0); -ELEMENTS[69754] = Fluid3D([13408,14360,14086,13942],0); -ELEMENTS[69755] = Fluid3D([14360,13972,14086,14637],0); -ELEMENTS[69756] = Fluid3D([14360,14086,13942,14486],0); -ELEMENTS[69757] = Fluid3D([14360,14086,14486,15014],0); -ELEMENTS[69758] = Fluid3D([14086,14486,15014,14500],0); -ELEMENTS[69759] = Fluid3D([14360,14086,15014,14856],0); -ELEMENTS[69760] = Fluid3D([3074,2828,3176,2980],0); -ELEMENTS[69761] = Fluid3D([2828,3176,2980,2701],0); -ELEMENTS[69762] = Fluid3D([7982,7898,8685,8540],0); -ELEMENTS[69763] = Fluid3D([7982,7898,8540,8220],0); -ELEMENTS[69764] = Fluid3D([4449,4443,3990,4368],0); -ELEMENTS[69765] = Fluid3D([3990,4449,4368,4459],0); -ELEMENTS[69766] = Fluid3D([4368,3990,4459,3879],0); -ELEMENTS[69767] = Fluid3D([3990,4459,3879,4449],0); -ELEMENTS[69768] = Fluid3D([6093,5642,5758,6463],0); -ELEMENTS[69769] = Fluid3D([11545,11424,12303,12253],0); -ELEMENTS[69770] = Fluid3D([4141,4390,4506,3786],0); -ELEMENTS[69771] = Fluid3D([4141,4390,3786,3949],0); -ELEMENTS[69772] = Fluid3D([5916,6194,5604,5430],0); -ELEMENTS[69773] = Fluid3D([16380,16274,16624,16731],0); -ELEMENTS[69774] = Fluid3D([4561,4909,4375,4184],0); -ELEMENTS[69775] = Fluid3D([18652,18660,18657,18574],0); -ELEMENTS[69776] = Fluid3D([17877,17563,17727,17988],0); -ELEMENTS[69777] = Fluid3D([6395,5785,6006,5967],0); -ELEMENTS[69778] = Fluid3D([2932,2820,2721,2480],0); -ELEMENTS[69779] = Fluid3D([10824,9604,10573,10364],0); -ELEMENTS[69780] = Fluid3D([10573,10824,10364,10914],0); -ELEMENTS[69781] = Fluid3D([2114,2064,2182,2267],0); -ELEMENTS[69782] = Fluid3D([2182,2114,2267,2379],0); -ELEMENTS[69783] = Fluid3D([14262,14849,14504,13863],0); -ELEMENTS[69784] = Fluid3D([3640,3817,3426,3229],0); -ELEMENTS[69785] = Fluid3D([16311,16892,16404,16375],0); -ELEMENTS[69786] = Fluid3D([16404,16311,16375,16166],0); -ELEMENTS[69787] = Fluid3D([3036,3313,2920,2804],0); -ELEMENTS[69788] = Fluid3D([13693,13293,13999,13518],0); -ELEMENTS[69789] = Fluid3D([18203,18032,17921,18043],0); -ELEMENTS[69790] = Fluid3D([3876,3660,3655,3367],0); -ELEMENTS[69791] = Fluid3D([11115,11544,10896,11832],0); -ELEMENTS[69792] = Fluid3D([16741,16311,16404,16146],0); -ELEMENTS[69793] = Fluid3D([15763,15496,16168,15785],0); -ELEMENTS[69794] = Fluid3D([12981,12129,12027,12149],0); -ELEMENTS[69795] = Fluid3D([7302,7679,7592,8285],0); -ELEMENTS[69796] = Fluid3D([5382,5390,4657,4845],0); -ELEMENTS[69797] = Fluid3D([9419,9590,9710,8840],0); -ELEMENTS[69798] = Fluid3D([10680,9857,9682,10010],0); -ELEMENTS[69799] = Fluid3D([11839,12207,11068,11365],0); -ELEMENTS[69800] = Fluid3D([17655,17599,17690,17325],0); -ELEMENTS[69801] = Fluid3D([17655,17599,17325,17214],0); -ELEMENTS[69802] = Fluid3D([11786,11146,10571,11647],0); -ELEMENTS[69803] = Fluid3D([3862,3898,3853,4441],0); -ELEMENTS[69804] = Fluid3D([16415,16419,15706,15801],0); -ELEMENTS[69805] = Fluid3D([6697,7509,7132,7706],0); -ELEMENTS[69806] = Fluid3D([7869,6980,6813,6803],0); -ELEMENTS[69807] = Fluid3D([15217,14861,14430,14657],0); -ELEMENTS[69808] = Fluid3D([16074,15652,15630,15655],0); -ELEMENTS[69809] = Fluid3D([17485,17603,17174,17415],0); -ELEMENTS[69810] = Fluid3D([7943,8619,8432,9215],0); -ELEMENTS[69811] = Fluid3D([7650,8405,8596,8618],0); -ELEMENTS[69812] = Fluid3D([10745,10777,9931,10769],0); -ELEMENTS[69813] = Fluid3D([16676,17191,17010,17131],0); -ELEMENTS[69814] = Fluid3D([18450,18501,18586,18590],0); -ELEMENTS[69815] = Fluid3D([11453,12420,12319,12748],0); -ELEMENTS[69816] = Fluid3D([11109,10658,11220,11972],0); -ELEMENTS[69817] = Fluid3D([3181,2794,3118,3223],0); -ELEMENTS[69818] = Fluid3D([15500,15793,15355,14727],0); -ELEMENTS[69819] = Fluid3D([17970,18046,17822,18142],0); -ELEMENTS[69820] = Fluid3D([17970,18046,18142,18221],0); -ELEMENTS[69821] = Fluid3D([17970,18046,18221,17896],0); -ELEMENTS[69822] = Fluid3D([10582,10190,9353,9516],0); -ELEMENTS[69823] = Fluid3D([9421,9107,9779,8976],0); -ELEMENTS[69824] = Fluid3D([16287,15596,15638,16038],0); -ELEMENTS[69825] = Fluid3D([4935,4883,4323,4334],0); -ELEMENTS[69826] = Fluid3D([11976,12038,11087,12120],0); -ELEMENTS[69827] = Fluid3D([9715,9451,8532,8325],0); -ELEMENTS[69828] = Fluid3D([2319,2340,2075,2116],0); -ELEMENTS[69829] = Fluid3D([16241,16517,15888,16577],0); -ELEMENTS[69830] = Fluid3D([17171,17491,17207,17347],0); -ELEMENTS[69831] = Fluid3D([16490,16882,16564,16350],0); -ELEMENTS[69832] = Fluid3D([4338,4150,3958,3897],0); -ELEMENTS[69833] = Fluid3D([4338,4150,3897,4272],0); -ELEMENTS[69834] = Fluid3D([14112,14427,13313,13535],0); -ELEMENTS[69835] = Fluid3D([3727,4037,3617,3605],0); -ELEMENTS[69836] = Fluid3D([3727,4037,3605,3948],0); -ELEMENTS[69837] = Fluid3D([3727,4037,3948,4097],0); -ELEMENTS[69838] = Fluid3D([3605,3727,3948,3619],0); -ELEMENTS[69839] = Fluid3D([3727,3948,3619,4097],0); -ELEMENTS[69840] = Fluid3D([3072,2756,3078,3361],0); -ELEMENTS[69841] = Fluid3D([3078,3072,3361,3269],0); -ELEMENTS[69842] = Fluid3D([5952,6495,6005,5742],0); -ELEMENTS[69843] = Fluid3D([2419,2408,2703,2728],0); -ELEMENTS[69844] = Fluid3D([5373,4780,5228,4977],0); -ELEMENTS[69845] = Fluid3D([14045,13966,14570,14767],0); -ELEMENTS[69846] = Fluid3D([6728,6353,6438,6861],0); -ELEMENTS[69847] = Fluid3D([14853,14057,14571,13781],0); -ELEMENTS[69848] = Fluid3D([14612,15303,14607,14947],0); -ELEMENTS[69849] = Fluid3D([1879,2080,1913,2086],0); -ELEMENTS[69850] = Fluid3D([6919,6813,7767,7769],0); -ELEMENTS[69851] = Fluid3D([12073,13015,12551,11895],0); -ELEMENTS[69852] = Fluid3D([12622,12939,12116,12910],0); -ELEMENTS[69853] = Fluid3D([18341,18467,18229,18445],0); -ELEMENTS[69854] = Fluid3D([13270,14068,13358,13986],0); -ELEMENTS[69855] = Fluid3D([8140,8515,9220,8204],0); -ELEMENTS[69856] = Fluid3D([8140,8515,8204,7129],0); -ELEMENTS[69857] = Fluid3D([17434,17335,17799,17589],0); -ELEMENTS[69858] = Fluid3D([16348,16557,16542,15974],0); -ELEMENTS[69859] = Fluid3D([15308,15626,15976,15398],0); -ELEMENTS[69860] = Fluid3D([4250,4595,4410,4998],0); -ELEMENTS[69861] = Fluid3D([13967,13315,13250,14401],0); -ELEMENTS[69862] = Fluid3D([15667,15391,15999,15780],0); -ELEMENTS[69863] = Fluid3D([7678,7042,7427,7657],0); -ELEMENTS[69864] = Fluid3D([8890,8829,7994,8708],0); -ELEMENTS[69865] = Fluid3D([5373,5723,6247,5907],0); -ELEMENTS[69866] = Fluid3D([5087,4893,4294,4654],0); -ELEMENTS[69867] = Fluid3D([9935,9488,10552,9956],0); -ELEMENTS[69868] = Fluid3D([4133,4027,3853,4279],0); -ELEMENTS[69869] = Fluid3D([4027,3853,4279,3818],0); -ELEMENTS[69870] = Fluid3D([3853,4133,4279,4441],0); -ELEMENTS[69871] = Fluid3D([9352,9659,10541,10061],0); -ELEMENTS[69872] = Fluid3D([7925,7266,8291,7629],0); -ELEMENTS[69873] = Fluid3D([4747,4348,4936,4622],0); -ELEMENTS[69874] = Fluid3D([12167,13049,12816,13309],0); -ELEMENTS[69875] = Fluid3D([12167,13049,13309,13142],0); -ELEMENTS[69876] = Fluid3D([10229,9367,10339,10969],0); -ELEMENTS[69877] = Fluid3D([12963,13352,13979,14074],0); -ELEMENTS[69878] = Fluid3D([11782,11551,12408,12910],0); -ELEMENTS[69879] = Fluid3D([11551,12408,12910,12116],0); -ELEMENTS[69880] = Fluid3D([11551,12408,12116,12578],0); -ELEMENTS[69881] = Fluid3D([12408,12116,12578,13170],0); -ELEMENTS[69882] = Fluid3D([3704,3336,3497,3473],0); -ELEMENTS[69883] = Fluid3D([3497,3704,3473,4159],0); -ELEMENTS[69884] = Fluid3D([3704,3336,3473,4032],0); -ELEMENTS[69885] = Fluid3D([3473,3704,4032,4159],0); -ELEMENTS[69886] = Fluid3D([2987,2954,3410,3025],0); -ELEMENTS[69887] = Fluid3D([5910,5958,5545,5855],0); -ELEMENTS[69888] = Fluid3D([12416,12561,12963,13601],0); -ELEMENTS[69889] = Fluid3D([13231,13824,13314,12664],0); -ELEMENTS[69890] = Fluid3D([16580,16449,16978,16699],0); -ELEMENTS[69891] = Fluid3D([13979,13908,13544,12762],0); -ELEMENTS[69892] = Fluid3D([14660,13722,14386,14020],0); -ELEMENTS[69893] = Fluid3D([6891,7117,6091,6536],0); -ELEMENTS[69894] = Fluid3D([9371,9888,9702,10767],0); -ELEMENTS[69895] = Fluid3D([3299,3246,3769,3484],0); -ELEMENTS[69896] = Fluid3D([3246,3769,3484,3553],0); -ELEMENTS[69897] = Fluid3D([8556,9000,9387,8247],0); -ELEMENTS[69898] = Fluid3D([13586,13287,13955,14330],0); -ELEMENTS[69899] = Fluid3D([13586,13287,14330,13705],0); -ELEMENTS[69900] = Fluid3D([18603,18653,18625,18596],0); -ELEMENTS[69901] = Fluid3D([12466,13020,11868,12519],0); -ELEMENTS[69902] = Fluid3D([12016,12014,11131,10807],0); -ELEMENTS[69903] = Fluid3D([17578,17381,17017,17350],0); -ELEMENTS[69904] = Fluid3D([5943,5479,5143,5419],0); -ELEMENTS[69905] = Fluid3D([4196,4097,3619,3948],0); -ELEMENTS[69906] = Fluid3D([3619,4196,3948,3640],0); -ELEMENTS[69907] = Fluid3D([4196,4097,3948,4037],0); -ELEMENTS[69908] = Fluid3D([4196,3948,3640,4241],0); -ELEMENTS[69909] = Fluid3D([4196,3948,4241,4037],0); -ELEMENTS[69910] = Fluid3D([3948,3640,4241,3605],0); -ELEMENTS[69911] = Fluid3D([3948,3640,3605,3619],0); -ELEMENTS[69912] = Fluid3D([3948,4241,4037,3934],0); -ELEMENTS[69913] = Fluid3D([6126,6144,6821,6955],0); -ELEMENTS[69914] = Fluid3D([1759,1791,1915,1698],0); -ELEMENTS[69915] = Fluid3D([15875,15431,15987,16033],0); -ELEMENTS[69916] = Fluid3D([15875,15431,16033,16048],0); -ELEMENTS[69917] = Fluid3D([15987,15875,16033,16665],0); -ELEMENTS[69918] = Fluid3D([14343,13874,14161,13871],0); -ELEMENTS[69919] = Fluid3D([6938,6462,7539,7143],0); -ELEMENTS[69920] = Fluid3D([12629,12177,11405,12207],0); -ELEMENTS[69921] = Fluid3D([14892,15002,14788,15453],0); -ELEMENTS[69922] = Fluid3D([11913,12053,12797,12530],0); -ELEMENTS[69923] = Fluid3D([17098,17420,17109,17367],0); -ELEMENTS[69924] = Fluid3D([17098,17420,17367,17355],0); -ELEMENTS[69925] = Fluid3D([1791,1664,1621,1698],0); -ELEMENTS[69926] = Fluid3D([3467,3222,3560,3676],0); -ELEMENTS[69927] = Fluid3D([14125,13814,14814,14350],0); -ELEMENTS[69928] = Fluid3D([3945,3669,3444,3738],0); -ELEMENTS[69929] = Fluid3D([5380,5959,5522,5948],0); -ELEMENTS[69930] = Fluid3D([6314,7040,6493,6020],0); -ELEMENTS[69931] = Fluid3D([7936,8657,9393,9230],0); -ELEMENTS[69932] = Fluid3D([12428,12245,12481,13349],0); -ELEMENTS[69933] = Fluid3D([17463,17138,17033,17120],0); -ELEMENTS[69934] = Fluid3D([4901,5132,4811,5682],0); -ELEMENTS[69935] = Fluid3D([16063,16054,15562,16412],0); -ELEMENTS[69936] = Fluid3D([13936,14372,14780,13702],0); -ELEMENTS[69937] = Fluid3D([4264,3927,4120,4215],0); -ELEMENTS[69938] = Fluid3D([5304,5238,5438,4875],0); -ELEMENTS[69939] = Fluid3D([6945,7118,7904,7458],0); -ELEMENTS[69940] = Fluid3D([16120,15812,16308,16406],0); -ELEMENTS[69941] = Fluid3D([3928,3917,4287,3544],0); -ELEMENTS[69942] = Fluid3D([9461,8512,9206,9214],0); -ELEMENTS[69943] = Fluid3D([3331,3329,3812,3530],0); -ELEMENTS[69944] = Fluid3D([9485,10639,10387,9693],0); -ELEMENTS[69945] = Fluid3D([2061,2032,1932,2200],0); -ELEMENTS[69946] = Fluid3D([15239,15030,14508,14999],0); -ELEMENTS[69947] = Fluid3D([16551,16582,17083,16729],0); -ELEMENTS[69948] = Fluid3D([5144,4462,4507,4751],0); -ELEMENTS[69949] = Fluid3D([12939,13434,12578,12116],0); -ELEMENTS[69950] = Fluid3D([12939,13434,12116,12910],0); -ELEMENTS[69951] = Fluid3D([15885,15641,16250,15869],0); -ELEMENTS[69952] = Fluid3D([7471,8389,7786,7871],0); -ELEMENTS[69953] = Fluid3D([18134,18017,18291,17919],0); -ELEMENTS[69954] = Fluid3D([9474,9410,9204,10178],0); -ELEMENTS[69955] = Fluid3D([13631,13291,14257,13390],0); -ELEMENTS[69956] = Fluid3D([17014,16667,17163,16898],0); -ELEMENTS[69957] = Fluid3D([15047,15359,14355,15062],0); -ELEMENTS[69958] = Fluid3D([6296,6614,7015,6067],0); -ELEMENTS[69959] = Fluid3D([8768,9241,9734,9176],0); -ELEMENTS[69960] = Fluid3D([8768,9241,9176,8243],0); -ELEMENTS[69961] = Fluid3D([5839,5413,5108,5416],0); -ELEMENTS[69962] = Fluid3D([17739,17535,17605,17734],0); -ELEMENTS[69963] = Fluid3D([8326,8204,8515,7409],0); -ELEMENTS[69964] = Fluid3D([6416,6432,6051,6741],0); -ELEMENTS[69965] = Fluid3D([6656,5959,5895,5948],0); -ELEMENTS[69966] = Fluid3D([10454,11374,10541,11460],0); -ELEMENTS[69967] = Fluid3D([15525,15058,15316,15894],0); -ELEMENTS[69968] = Fluid3D([9940,9472,9954,10094],0); -ELEMENTS[69969] = Fluid3D([17026,16936,17008,17391],0); -ELEMENTS[69970] = Fluid3D([10299,10744,11667,11265],0); -ELEMENTS[69971] = Fluid3D([10299,10744,11265,11356],0); -ELEMENTS[69972] = Fluid3D([10299,10744,11356,10535],0); -ELEMENTS[69973] = Fluid3D([12903,13342,13650,12682],0); -ELEMENTS[69974] = Fluid3D([12903,13342,12682,11795],0); -ELEMENTS[69975] = Fluid3D([13342,13650,12682,12422],0); -ELEMENTS[69976] = Fluid3D([12682,13342,12422,11795],0); -ELEMENTS[69977] = Fluid3D([12422,12682,11795,12293],0); -ELEMENTS[69978] = Fluid3D([12682,11795,12293,12903],0); -ELEMENTS[69979] = Fluid3D([12422,12682,12293,12601],0); -ELEMENTS[69980] = Fluid3D([12682,12293,12601,13650],0); -ELEMENTS[69981] = Fluid3D([12422,12682,12601,13650],0); -ELEMENTS[69982] = Fluid3D([10213,10010,11131,10680],0); -ELEMENTS[69983] = Fluid3D([7329,6718,6664,7005],0); -ELEMENTS[69984] = Fluid3D([11459,11665,10943,12318],0); -ELEMENTS[69985] = Fluid3D([16549,16265,16754,16694],0); -ELEMENTS[69986] = Fluid3D([14491,14686,15020,14812],0); -ELEMENTS[69987] = Fluid3D([14686,15020,14812,15364],0); -ELEMENTS[69988] = Fluid3D([4278,4774,4896,4241],0); -ELEMENTS[69989] = Fluid3D([1693,1811,1759,1803],0); -ELEMENTS[69990] = Fluid3D([1693,1811,1803,1932],0); -ELEMENTS[69991] = Fluid3D([1811,1759,1803,1878],0); -ELEMENTS[69992] = Fluid3D([1759,1803,1878,1746],0); -ELEMENTS[69993] = Fluid3D([1811,1803,1932,1878],0); -ELEMENTS[69994] = Fluid3D([1811,1759,1878,1915],0); -ELEMENTS[69995] = Fluid3D([1811,1759,1915,1698],0); -ELEMENTS[69996] = Fluid3D([1915,1811,1698,1809],0); -ELEMENTS[69997] = Fluid3D([5686,5240,5957,5458],0); -ELEMENTS[69998] = Fluid3D([15380,15566,15061,14594],0); -ELEMENTS[69999] = Fluid3D([15649,15643,14944,14969],0); -ELEMENTS[70000] = Fluid3D([14579,14089,13915,14738],0); -ELEMENTS[70001] = Fluid3D([14579,14089,14738,14937],0); -ELEMENTS[70002] = Fluid3D([9597,10498,10470,9898],0); -ELEMENTS[70003] = Fluid3D([10470,9597,9898,9208],0); -ELEMENTS[70004] = Fluid3D([9597,10498,9898,10503],0); -ELEMENTS[70005] = Fluid3D([9898,9597,10503,9255],0); -ELEMENTS[70006] = Fluid3D([9898,9597,9255,8882],0); -ELEMENTS[70007] = Fluid3D([9255,9898,8882,10185],0); -ELEMENTS[70008] = Fluid3D([9898,9597,8882,9208],0); -ELEMENTS[70009] = Fluid3D([9597,9255,8882,8379],0); -ELEMENTS[70010] = Fluid3D([9255,9898,10185,10503],0); -ELEMENTS[70011] = Fluid3D([14798,14594,14416,15177],0); -ELEMENTS[70012] = Fluid3D([2823,2501,2598,2910],0); -ELEMENTS[70013] = Fluid3D([5460,5751,5186,5786],0); -ELEMENTS[70014] = Fluid3D([4369,3890,4275,4494],0); -ELEMENTS[70015] = Fluid3D([6316,6191,5601,5783],0); -ELEMENTS[70016] = Fluid3D([17999,17701,17788,17933],0); -ELEMENTS[70017] = Fluid3D([10146,11061,10422,10264],0); -ELEMENTS[70018] = Fluid3D([10195,10869,11307,10581],0); -ELEMENTS[70019] = Fluid3D([11205,10741,11078,12072],0); -ELEMENTS[70020] = Fluid3D([11717,12527,12298,12611],0); -ELEMENTS[70021] = Fluid3D([17972,17946,17638,18175],0); -ELEMENTS[70022] = Fluid3D([9835,10883,10637,9894],0); -ELEMENTS[70023] = Fluid3D([3071,3445,3175,2954],0); -ELEMENTS[70024] = Fluid3D([7829,7472,8006,7353],0); -ELEMENTS[70025] = Fluid3D([10659,10678,10051,9589],0); -ELEMENTS[70026] = Fluid3D([15436,15961,15806,15492],0); -ELEMENTS[70027] = Fluid3D([17355,17210,17098,17420],0); -ELEMENTS[70028] = Fluid3D([13593,13146,12907,12643],0); -ELEMENTS[70029] = Fluid3D([2146,2279,2022,2166],0); -ELEMENTS[70030] = Fluid3D([2800,2566,3032,2637],0); -ELEMENTS[70031] = Fluid3D([2800,2566,2637,2602],0); -ELEMENTS[70032] = Fluid3D([12310,13258,12635,13625],0); -ELEMENTS[70033] = Fluid3D([18578,18518,18520,18643],0); -ELEMENTS[70034] = Fluid3D([7143,7730,8151,6938],0); -ELEMENTS[70035] = Fluid3D([15034,15382,15641,14607],0); -ELEMENTS[70036] = Fluid3D([11239,11771,10605,11921],0); -ELEMENTS[70037] = Fluid3D([14330,14361,14806,13705],0); -ELEMENTS[70038] = Fluid3D([14330,14361,13705,13287],0); -ELEMENTS[70039] = Fluid3D([9108,8734,8209,7740],0); -ELEMENTS[70040] = Fluid3D([6013,6653,6645,6134],0); -ELEMENTS[70041] = Fluid3D([3485,3829,3560,3187],0); -ELEMENTS[70042] = Fluid3D([3485,3829,3187,3688],0); -ELEMENTS[70043] = Fluid3D([14758,15300,15405,15212],0); -ELEMENTS[70044] = Fluid3D([17356,17135,17665,17550],0); -ELEMENTS[70045] = Fluid3D([4726,5174,4769,5220],0); -ELEMENTS[70046] = Fluid3D([15986,16221,15651,15626],0); -ELEMENTS[70047] = Fluid3D([11566,11722,12127,12582],0); -ELEMENTS[70048] = Fluid3D([11904,12625,12157,12181],0); -ELEMENTS[70049] = Fluid3D([12625,12157,12181,12921],0); -ELEMENTS[70050] = Fluid3D([12181,12625,12921,13097],0); -ELEMENTS[70051] = Fluid3D([9069,9646,8811,8469],0); -ELEMENTS[70052] = Fluid3D([8811,9069,8469,8170],0); -ELEMENTS[70053] = Fluid3D([15144,14685,14599,14520],0); -ELEMENTS[70054] = Fluid3D([16957,16935,17254,17473],0); -ELEMENTS[70055] = Fluid3D([9457,10011,10653,10947],0); -ELEMENTS[70056] = Fluid3D([9475,8547,9213,8428],0); -ELEMENTS[70057] = Fluid3D([11460,12217,12228,11083],0); -ELEMENTS[70058] = Fluid3D([17311,16918,16967,16786],0); -ELEMENTS[70059] = Fluid3D([14607,14466,15034,15382],0); -ELEMENTS[70060] = Fluid3D([14002,14443,13676,13896],0); -ELEMENTS[70061] = Fluid3D([17407,17219,17641,17606],0); -ELEMENTS[70062] = Fluid3D([3267,3094,2886,2945],0); -ELEMENTS[70063] = Fluid3D([9348,9567,9825,8948],0); -ELEMENTS[70064] = Fluid3D([4132,3842,3794,4467],0); -ELEMENTS[70065] = Fluid3D([11002,10960,11739,11841],0); -ELEMENTS[70066] = Fluid3D([11002,10960,11841,11779],0); -ELEMENTS[70067] = Fluid3D([10960,11739,11841,12114],0); -ELEMENTS[70068] = Fluid3D([11841,10960,12114,11557],0); -ELEMENTS[70069] = Fluid3D([12114,11841,11557,11779],0); -ELEMENTS[70070] = Fluid3D([12114,11841,11779,12476],0); -ELEMENTS[70071] = Fluid3D([12114,11841,12476,11739],0); -ELEMENTS[70072] = Fluid3D([11841,11779,12476,11572],0); -ELEMENTS[70073] = Fluid3D([12476,11841,11572,11739],0); -ELEMENTS[70074] = Fluid3D([11841,11557,11779,10960],0); -ELEMENTS[70075] = Fluid3D([11841,11572,11739,11002],0); -ELEMENTS[70076] = Fluid3D([11841,11572,11002,11779],0); -ELEMENTS[70077] = Fluid3D([11572,11739,11002,11363],0); -ELEMENTS[70078] = Fluid3D([11002,11572,11363,11514],0); -ELEMENTS[70079] = Fluid3D([11002,11572,11514,12032],0); -ELEMENTS[70080] = Fluid3D([8794,9440,8075,8622],0); -ELEMENTS[70081] = Fluid3D([5946,5341,5548,4888],0); -ELEMENTS[70082] = Fluid3D([8226,9126,9506,9179],0); -ELEMENTS[70083] = Fluid3D([8226,9126,9179,8815],0); -ELEMENTS[70084] = Fluid3D([13276,13741,14275,13949],0); -ELEMENTS[70085] = Fluid3D([14358,14085,15077,14816],0); -ELEMENTS[70086] = Fluid3D([10148,10222,11201,10659],0); -ELEMENTS[70087] = Fluid3D([10148,10222,10659,9216],0); -ELEMENTS[70088] = Fluid3D([14985,15284,14498,14216],0); -ELEMENTS[70089] = Fluid3D([5392,5112,5328,4816],0); -ELEMENTS[70090] = Fluid3D([2098,2087,1975,1875],0); -ELEMENTS[70091] = Fluid3D([1975,2098,1875,2056],0); -ELEMENTS[70092] = Fluid3D([17081,16555,16762,16799],0); -ELEMENTS[70093] = Fluid3D([13955,14540,14397,14539],0); -ELEMENTS[70094] = Fluid3D([5847,5229,5454,6185],0); -ELEMENTS[70095] = Fluid3D([16134,16569,16448,16084],0); -ELEMENTS[70096] = Fluid3D([3569,3910,4075,4175],0); -ELEMENTS[70097] = Fluid3D([16222,16529,15966,15745],0); -ELEMENTS[70098] = Fluid3D([10325,11175,10847,10069],0); -ELEMENTS[70099] = Fluid3D([15119,15509,15420,16174],0); -ELEMENTS[70100] = Fluid3D([17002,16755,16976,17027],0); -ELEMENTS[70101] = Fluid3D([17002,16755,17027,16558],0); -ELEMENTS[70102] = Fluid3D([17002,16755,16558,16698],0); -ELEMENTS[70103] = Fluid3D([6146,5657,5299,5637],0); -ELEMENTS[70104] = Fluid3D([5006,5477,5178,4718],0); -ELEMENTS[70105] = Fluid3D([10029,11424,9961,10699],0); -ELEMENTS[70106] = Fluid3D([9961,10029,10699,9850],0); -ELEMENTS[70107] = Fluid3D([9961,10029,9850,9109],0); -ELEMENTS[70108] = Fluid3D([9961,10029,9109,9583],0); -ELEMENTS[70109] = Fluid3D([6980,7869,6959,6803],0); -ELEMENTS[70110] = Fluid3D([10772,11004,10727,11676],0); -ELEMENTS[70111] = Fluid3D([4998,5509,5561,5523],0); -ELEMENTS[70112] = Fluid3D([11458,10558,10887,11966],0); -ELEMENTS[70113] = Fluid3D([9402,9223,8890,9681],0); -ELEMENTS[70114] = Fluid3D([9223,8890,9681,9858],0); -ELEMENTS[70115] = Fluid3D([9223,8890,9858,8965],0); -ELEMENTS[70116] = Fluid3D([12739,12459,13336,13297],0); -ELEMENTS[70117] = Fluid3D([14621,14182,14572,15230],0); -ELEMENTS[70118] = Fluid3D([7721,8410,8366,8114],0); -ELEMENTS[70119] = Fluid3D([2914,2667,2844,2738],0); -ELEMENTS[70120] = Fluid3D([11220,10696,11322,12037],0); -ELEMENTS[70121] = Fluid3D([11322,11220,12037,11876],0); -ELEMENTS[70122] = Fluid3D([12748,12974,13330,13710],0); -ELEMENTS[70123] = Fluid3D([5976,5814,5772,6433],0); -ELEMENTS[70124] = Fluid3D([5976,5814,6433,7026],0); -ELEMENTS[70125] = Fluid3D([15715,15686,16171,15704],0); -ELEMENTS[70126] = Fluid3D([2075,2262,2319,2250],0); -ELEMENTS[70127] = Fluid3D([17351,17314,17662,17757],0); -ELEMENTS[70128] = Fluid3D([5843,5415,5165,4977],0); -ELEMENTS[70129] = Fluid3D([2243,2481,2245,2276],0); -ELEMENTS[70130] = Fluid3D([2681,2463,2431,2561],0); -ELEMENTS[70131] = Fluid3D([6333,5990,6080,5661],0); -ELEMENTS[70132] = Fluid3D([6333,5990,5661,6250],0); -ELEMENTS[70133] = Fluid3D([11523,10962,10542,10570],0); -ELEMENTS[70134] = Fluid3D([10061,9573,8863,9659],0); -ELEMENTS[70135] = Fluid3D([9573,8863,9659,8808],0); -ELEMENTS[70136] = Fluid3D([8665,8193,9102,8647],0); -ELEMENTS[70137] = Fluid3D([4566,4537,4896,5175],0); -ELEMENTS[70138] = Fluid3D([13458,14235,12947,13725],0); -ELEMENTS[70139] = Fluid3D([16769,16373,16773,16324],0); -ELEMENTS[70140] = Fluid3D([16769,16373,16324,16164],0); -ELEMENTS[70141] = Fluid3D([4120,4207,3847,3594],0); -ELEMENTS[70142] = Fluid3D([12961,13619,13626,13511],0); -ELEMENTS[70143] = Fluid3D([15164,15320,15702,15116],0); -ELEMENTS[70144] = Fluid3D([15175,14604,15399,14321],0); -ELEMENTS[70145] = Fluid3D([15175,14604,14321,14379],0); -ELEMENTS[70146] = Fluid3D([13400,13405,14057,14412],0); -ELEMENTS[70147] = Fluid3D([11412,11516,10388,10967],0); -ELEMENTS[70148] = Fluid3D([11412,11516,10967,12175],0); -ELEMENTS[70149] = Fluid3D([4911,5395,4634,4756],0); -ELEMENTS[70150] = Fluid3D([18423,18395,18216,18228],0); -ELEMENTS[70151] = Fluid3D([5454,5229,5566,6185],0); -ELEMENTS[70152] = Fluid3D([5219,4561,4730,4538],0); -ELEMENTS[70153] = Fluid3D([10282,9724,9299,10408],0); -ELEMENTS[70154] = Fluid3D([17123,17306,16717,16750],0); -ELEMENTS[70155] = Fluid3D([11294,10949,12120,11087],0); -ELEMENTS[70156] = Fluid3D([11294,10949,11087,10430],0); -ELEMENTS[70157] = Fluid3D([3643,4049,4286,4032],0); -ELEMENTS[70158] = Fluid3D([4049,4286,4032,4567],0); -ELEMENTS[70159] = Fluid3D([4049,4286,4567,4506],0); -ELEMENTS[70160] = Fluid3D([4032,4049,4567,4159],0); -ELEMENTS[70161] = Fluid3D([4049,4567,4159,4506],0); -ELEMENTS[70162] = Fluid3D([10563,10069,10847,11391],0); -ELEMENTS[70163] = Fluid3D([6396,5917,6164,6748],0); -ELEMENTS[70164] = Fluid3D([14952,15486,14877,15502],0); -ELEMENTS[70165] = Fluid3D([14021,14335,14913,14542],0); -ELEMENTS[70166] = Fluid3D([17052,17147,17374,16745],0); -ELEMENTS[70167] = Fluid3D([16585,16345,17039,16800],0); -ELEMENTS[70168] = Fluid3D([13282,13539,12423,13660],0); -ELEMENTS[70169] = Fluid3D([7889,8608,8379,8648],0); -ELEMENTS[70170] = Fluid3D([2635,2892,2607,2882],0); -ELEMENTS[70171] = Fluid3D([2607,2635,2882,2756],0); -ELEMENTS[70172] = Fluid3D([2882,2607,2756,3120],0); -ELEMENTS[70173] = Fluid3D([2756,2882,3120,2998],0); -ELEMENTS[70174] = Fluid3D([2756,2882,2998,2635],0); -ELEMENTS[70175] = Fluid3D([2882,3120,2998,3263],0); -ELEMENTS[70176] = Fluid3D([2998,2882,3263,2892],0); -ELEMENTS[70177] = Fluid3D([2882,3120,3263,2892],0); -ELEMENTS[70178] = Fluid3D([2882,2998,2635,2892],0); -ELEMENTS[70179] = Fluid3D([2882,2607,3120,2892],0); -ELEMENTS[70180] = Fluid3D([9231,8633,8917,9885],0); -ELEMENTS[70181] = Fluid3D([10500,9501,10587,10298],0); -ELEMENTS[70182] = Fluid3D([13913,14608,14308,14300],0); -ELEMENTS[70183] = Fluid3D([15572,15432,15018,14878],0); -ELEMENTS[70184] = Fluid3D([11082,11789,11162,12209],0); -ELEMENTS[70185] = Fluid3D([3337,3492,3583,3985],0); -ELEMENTS[70186] = Fluid3D([17947,17643,17645,17560],0); -ELEMENTS[70187] = Fluid3D([1721,1879,1746,1818],0); -ELEMENTS[70188] = Fluid3D([7311,8115,7078,7190],0); -ELEMENTS[70189] = Fluid3D([16687,16382,16916,17043],0); -ELEMENTS[70190] = Fluid3D([8702,7873,7829,7926],0); -ELEMENTS[70191] = Fluid3D([6872,6304,6769,7561],0); -ELEMENTS[70192] = Fluid3D([7494,7093,6916,6887],0); -ELEMENTS[70193] = Fluid3D([14791,15096,14258,14645],0); -ELEMENTS[70194] = Fluid3D([14791,15096,14645,15522],0); -ELEMENTS[70195] = Fluid3D([15518,15708,14935,15369],0); -ELEMENTS[70196] = Fluid3D([9655,9387,9000,8247],0); -ELEMENTS[70197] = Fluid3D([12445,12240,12903,11795],0); -ELEMENTS[70198] = Fluid3D([16246,16260,16609,16834],0); -ELEMENTS[70199] = Fluid3D([6587,6742,6044,5914],0); -ELEMENTS[70200] = Fluid3D([15891,16049,16621,16261],0); -ELEMENTS[70201] = Fluid3D([16351,16434,16718,16781],0); -ELEMENTS[70202] = Fluid3D([16351,16434,16781,16834],0); -ELEMENTS[70203] = Fluid3D([14612,14885,14977,14765],0); -ELEMENTS[70204] = Fluid3D([14612,14885,14765,14145],0); -ELEMENTS[70205] = Fluid3D([18609,18577,18473,18600],0); -ELEMENTS[70206] = Fluid3D([10373,9463,9618,10191],0); -ELEMENTS[70207] = Fluid3D([10373,9463,10191,10159],0); -ELEMENTS[70208] = Fluid3D([10373,9463,10159,10098],0); -ELEMENTS[70209] = Fluid3D([9463,10191,10159,9576],0); -ELEMENTS[70210] = Fluid3D([10191,10373,10159,11088],0); -ELEMENTS[70211] = Fluid3D([9463,10159,10098,9576],0); -ELEMENTS[70212] = Fluid3D([10159,10098,9576,10870],0); -ELEMENTS[70213] = Fluid3D([10373,10159,11088,10098],0); -ELEMENTS[70214] = Fluid3D([10159,11088,10098,10870],0); -ELEMENTS[70215] = Fluid3D([10159,11088,10870,10191],0); -ELEMENTS[70216] = Fluid3D([10191,10159,9576,10870],0); -ELEMENTS[70217] = Fluid3D([9463,9618,10191,8884],0); -ELEMENTS[70218] = Fluid3D([10540,9696,10509,9751],0); -ELEMENTS[70219] = Fluid3D([13077,12292,11739,12476],0); -ELEMENTS[70220] = Fluid3D([9889,9003,10400,9660],0); -ELEMENTS[70221] = Fluid3D([15572,15687,16219,16233],0); -ELEMENTS[70222] = Fluid3D([13872,14599,13645,14375],0); -ELEMENTS[70223] = Fluid3D([11284,10593,10322,10848],0); -ELEMENTS[70224] = Fluid3D([10593,10322,10848,9808],0); -ELEMENTS[70225] = Fluid3D([10848,10593,9808,9847],0); -ELEMENTS[70226] = Fluid3D([9808,10848,9847,9378],0); -ELEMENTS[70227] = Fluid3D([9847,9808,9378,8871],0); -ELEMENTS[70228] = Fluid3D([9847,9808,8871,9827],0); -ELEMENTS[70229] = Fluid3D([10593,9808,9847,9827],0); -ELEMENTS[70230] = Fluid3D([10593,9808,9827,9400],0); -ELEMENTS[70231] = Fluid3D([10593,9808,9400,10322],0); -ELEMENTS[70232] = Fluid3D([9808,9400,10322,9378],0); -ELEMENTS[70233] = Fluid3D([9808,9400,9378,8871],0); -ELEMENTS[70234] = Fluid3D([9808,9400,8871,9827],0); -ELEMENTS[70235] = Fluid3D([10322,9808,9378,10848],0); -ELEMENTS[70236] = Fluid3D([9820,10396,10314,10058],0); -ELEMENTS[70237] = Fluid3D([9820,10396,10058,9103],0); -ELEMENTS[70238] = Fluid3D([18469,18435,18350,18421],0); -ELEMENTS[70239] = Fluid3D([18350,18469,18421,18562],0); -ELEMENTS[70240] = Fluid3D([6553,5752,6034,5733],0); -ELEMENTS[70241] = Fluid3D([10918,11080,12034,10873],0); -ELEMENTS[70242] = Fluid3D([11457,10889,10622,10108],0); -ELEMENTS[70243] = Fluid3D([12377,12238,12646,13369],0); -ELEMENTS[70244] = Fluid3D([5320,4928,4646,5084],0); -ELEMENTS[70245] = Fluid3D([17344,17535,17253,16914],0); -ELEMENTS[70246] = Fluid3D([14983,15249,15607,15575],0); -ELEMENTS[70247] = Fluid3D([6330,6351,5748,5455],0); -ELEMENTS[70248] = Fluid3D([5486,5780,6126,6248],0); -ELEMENTS[70249] = Fluid3D([7742,6981,7502,7379],0); -ELEMENTS[70250] = Fluid3D([8351,8745,9261,8195],0); -ELEMENTS[70251] = Fluid3D([8351,8745,8195,7443],0); -ELEMENTS[70252] = Fluid3D([11553,12529,12171,11618],0); -ELEMENTS[70253] = Fluid3D([6396,6504,7126,7299],0); -ELEMENTS[70254] = Fluid3D([9084,9906,9355,9865],0); -ELEMENTS[70255] = Fluid3D([9620,9965,10855,10755],0); -ELEMENTS[70256] = Fluid3D([18346,18423,18500,18499],0); -ELEMENTS[70257] = Fluid3D([18346,18423,18499,18381],0); -ELEMENTS[70258] = Fluid3D([18499,18346,18381,18367],0); -ELEMENTS[70259] = Fluid3D([9701,10069,9259,9132],0); -ELEMENTS[70260] = Fluid3D([10069,9259,9132,10325],0); -ELEMENTS[70261] = Fluid3D([13791,13990,13282,14125],0); -ELEMENTS[70262] = Fluid3D([13791,13990,14125,14665],0); -ELEMENTS[70263] = Fluid3D([13049,13851,12949,12816],0); -ELEMENTS[70264] = Fluid3D([12949,13049,12816,11613],0); -ELEMENTS[70265] = Fluid3D([5846,6143,6444,6886],0); -ELEMENTS[70266] = Fluid3D([10330,10812,11647,10983],0); -ELEMENTS[70267] = Fluid3D([8291,8614,8858,9392],0); -ELEMENTS[70268] = Fluid3D([18503,18433,18391,18496],0); -ELEMENTS[70269] = Fluid3D([2529,2816,2721,2863],0); -ELEMENTS[70270] = Fluid3D([4871,4489,4442,4015],0); -ELEMENTS[70271] = Fluid3D([11887,11725,11395,10800],0); -ELEMENTS[70272] = Fluid3D([14845,15201,15020,15677],0); -ELEMENTS[70273] = Fluid3D([10582,10079,10628,9516],0); -ELEMENTS[70274] = Fluid3D([8913,9052,9485,8157],0); -ELEMENTS[70275] = Fluid3D([12929,12806,13428,12610],0); -ELEMENTS[70276] = Fluid3D([17550,17696,17402,17088],0); -ELEMENTS[70277] = Fluid3D([14241,14409,14808,14460],0); -ELEMENTS[70278] = Fluid3D([3098,2844,3053,2648],0); -ELEMENTS[70279] = Fluid3D([17722,17417,17813,17884],0); -ELEMENTS[70280] = Fluid3D([3876,4142,4606,4048],0); -ELEMENTS[70281] = Fluid3D([3118,3382,3381,3783],0); -ELEMENTS[70282] = Fluid3D([12089,11681,12801,12543],0); -ELEMENTS[70283] = Fluid3D([9913,10255,10529,9477],0); -ELEMENTS[70284] = Fluid3D([18060,18082,18210,18380],0); -ELEMENTS[70285] = Fluid3D([8803,8664,9950,8979],0); -ELEMENTS[70286] = Fluid3D([5656,5174,5637,5299],0); -ELEMENTS[70287] = Fluid3D([5656,5174,5299,5220],0); -ELEMENTS[70288] = Fluid3D([6951,6773,6636,6218],0); -ELEMENTS[70289] = Fluid3D([15593,15804,15575,16261],0); -ELEMENTS[70290] = Fluid3D([3188,2875,3343,2836],0); -ELEMENTS[70291] = Fluid3D([8364,8340,7676,7252],0); -ELEMENTS[70292] = Fluid3D([6068,6236,6219,6878],0); -ELEMENTS[70293] = Fluid3D([10382,10430,11495,11316],0); -ELEMENTS[70294] = Fluid3D([16893,16947,17264,16591],0); -ELEMENTS[70295] = Fluid3D([18524,18388,18473,18417],0); -ELEMENTS[70296] = Fluid3D([18618,18553,18543,18548],0); -ELEMENTS[70297] = Fluid3D([18618,18553,18548,18624],0); -ELEMENTS[70298] = Fluid3D([9286,9400,9907,9131],0); -ELEMENTS[70299] = Fluid3D([16727,17116,16830,16914],0); -ELEMENTS[70300] = Fluid3D([10640,11299,10743,10956],0); -ELEMENTS[70301] = Fluid3D([8691,8695,9692,9645],0); -ELEMENTS[70302] = Fluid3D([16290,16745,16917,16416],0); -ELEMENTS[70303] = Fluid3D([5278,5830,5759,5804],0); -ELEMENTS[70304] = Fluid3D([11620,11444,10764,11868],0); -ELEMENTS[70305] = Fluid3D([5652,5478,6152,6189],0); -ELEMENTS[70306] = Fluid3D([17264,17638,17273,17354],0); -ELEMENTS[70307] = Fluid3D([5341,5548,4888,4886],0); -ELEMENTS[70308] = Fluid3D([5319,5654,5976,5307],0); -ELEMENTS[70309] = Fluid3D([18535,18520,18518,18628],0); -ELEMENTS[70310] = Fluid3D([7749,8067,8502,7241],0); -ELEMENTS[70311] = Fluid3D([16575,16375,16404,16892],0); -ELEMENTS[70312] = Fluid3D([7465,6984,6868,7572],0); -ELEMENTS[70313] = Fluid3D([8808,8389,9351,9573],0); -ELEMENTS[70314] = Fluid3D([7122,7663,7771,7895],0); -ELEMENTS[70315] = Fluid3D([7771,7122,7895,7234],0); -ELEMENTS[70316] = Fluid3D([12809,12801,12780,13775],0); -ELEMENTS[70317] = Fluid3D([13460,13043,12614,12625],0); -ELEMENTS[70318] = Fluid3D([13460,13043,12625,13827],0); -ELEMENTS[70319] = Fluid3D([5283,4857,4531,4775],0); -ELEMENTS[70320] = Fluid3D([18688,18679,18696,18687],0); -ELEMENTS[70321] = Fluid3D([15282,15819,15546,15800],0); -ELEMENTS[70322] = Fluid3D([4907,4733,4288,4999],0); -ELEMENTS[70323] = Fluid3D([4907,4733,4999,5611],0); -ELEMENTS[70324] = Fluid3D([16253,16207,16449,15849],0); -ELEMENTS[70325] = Fluid3D([6461,6697,7132,6349],0); -ELEMENTS[70326] = Fluid3D([6461,6697,6349,5822],0); -ELEMENTS[70327] = Fluid3D([16710,16981,17034,16606],0); -ELEMENTS[70328] = Fluid3D([16031,15633,16134,16448],0); -ELEMENTS[70329] = Fluid3D([15964,16419,16362,15801],0); -ELEMENTS[70330] = Fluid3D([16145,16004,16526,16254],0); -ELEMENTS[70331] = Fluid3D([4478,4741,4560,5125],0); -ELEMENTS[70332] = Fluid3D([3740,4010,4231,4069],0); -ELEMENTS[70333] = Fluid3D([5295,5955,5369,5537],0); -ELEMENTS[70334] = Fluid3D([18172,18103,18269,17958],0); -ELEMENTS[70335] = Fluid3D([9309,10044,9884,9547],0); -ELEMENTS[70336] = Fluid3D([3751,4047,4040,3665],0); -ELEMENTS[70337] = Fluid3D([3751,4047,3665,3537],0); -ELEMENTS[70338] = Fluid3D([4047,4040,3665,3822],0); -ELEMENTS[70339] = Fluid3D([4040,3751,3665,3385],0); -ELEMENTS[70340] = Fluid3D([3751,3665,3385,3537],0); -ELEMENTS[70341] = Fluid3D([3665,3385,3537,3540],0); -ELEMENTS[70342] = Fluid3D([3665,3385,3540,3509],0); -ELEMENTS[70343] = Fluid3D([3665,3385,3509,4040],0); -ELEMENTS[70344] = Fluid3D([3509,3665,4040,3822],0); -ELEMENTS[70345] = Fluid3D([3509,3665,3822,3540],0); -ELEMENTS[70346] = Fluid3D([3537,3665,3540,4047],0); -ELEMENTS[70347] = Fluid3D([3955,3926,4237,3680],0); -ELEMENTS[70348] = Fluid3D([18638,18665,18659,18586],0); -ELEMENTS[70349] = Fluid3D([3517,3559,3661,3940],0); -ELEMENTS[70350] = Fluid3D([16910,16796,16464,16164],0); -ELEMENTS[70351] = Fluid3D([13649,13780,13138,13918],0); -ELEMENTS[70352] = Fluid3D([18160,17879,18231,17840],0); -ELEMENTS[70353] = Fluid3D([15215,15034,15771,15343],0); -ELEMENTS[70354] = Fluid3D([11244,11310,10376,11488],0); -ELEMENTS[70355] = Fluid3D([15465,14818,14758,14875],0); -ELEMENTS[70356] = Fluid3D([18510,18615,18520,18549],0); -ELEMENTS[70357] = Fluid3D([5912,6123,6135,6244],0); -ELEMENTS[70358] = Fluid3D([6957,6669,7291,6372],0); -ELEMENTS[70359] = Fluid3D([10778,10131,11409,11073],0); -ELEMENTS[70360] = Fluid3D([15921,16200,16341,16073],0); -ELEMENTS[70361] = Fluid3D([16341,15921,16073,15827],0); -ELEMENTS[70362] = Fluid3D([15921,16200,16073,16525],0); -ELEMENTS[70363] = Fluid3D([10283,9835,9103,9252],0); -ELEMENTS[70364] = Fluid3D([4555,4973,4593,4762],0); -ELEMENTS[70365] = Fluid3D([9441,10072,9334,8923],0); -ELEMENTS[70366] = Fluid3D([13669,13304,13471,12405],0); -ELEMENTS[70367] = Fluid3D([15836,15936,16368,15768],0); -ELEMENTS[70368] = Fluid3D([17808,17634,17662,17660],0); -ELEMENTS[70369] = Fluid3D([10441,9441,10072,10688],0); -ELEMENTS[70370] = Fluid3D([11215,10858,10282,9724],0); -ELEMENTS[70371] = Fluid3D([10858,10282,9724,9918],0); -ELEMENTS[70372] = Fluid3D([2263,2109,1995,2124],0); -ELEMENTS[70373] = Fluid3D([5341,5760,4888,5320],0); -ELEMENTS[70374] = Fluid3D([4888,5341,5320,5946],0); -ELEMENTS[70375] = Fluid3D([14373,14359,15140,14545],0); -ELEMENTS[70376] = Fluid3D([2019,2116,2250,1989],0); -ELEMENTS[70377] = Fluid3D([14122,13402,13758,13798],0); -ELEMENTS[70378] = Fluid3D([11819,12178,12195,11521],0); -ELEMENTS[70379] = Fluid3D([12195,11819,11521,11280],0); -ELEMENTS[70380] = Fluid3D([11521,12195,11280,11240],0); -ELEMENTS[70381] = Fluid3D([11819,12178,11521,11277],0); -ELEMENTS[70382] = Fluid3D([11819,12178,11277,11212],0); -ELEMENTS[70383] = Fluid3D([11819,11521,11280,10447],0); -ELEMENTS[70384] = Fluid3D([8708,9057,8056,8807],0); -ELEMENTS[70385] = Fluid3D([15204,14496,15099,14462],0); -ELEMENTS[70386] = Fluid3D([15204,14496,14462,15316],0); -ELEMENTS[70387] = Fluid3D([7776,7867,7188,8055],0); -ELEMENTS[70388] = Fluid3D([6879,7712,7392,7629],0); -ELEMENTS[70389] = Fluid3D([7833,8381,8243,8232],0); -ELEMENTS[70390] = Fluid3D([16461,16319,16970,16968],0); -ELEMENTS[70391] = Fluid3D([15786,16323,16348,16157],0); -ELEMENTS[70392] = Fluid3D([18114,18172,18388,18387],0); -ELEMENTS[70393] = Fluid3D([9293,8585,8692,9620],0); -ELEMENTS[70394] = Fluid3D([9293,8585,9620,9773],0); -ELEMENTS[70395] = Fluid3D([7613,7193,6856,6332],0); -ELEMENTS[70396] = Fluid3D([15936,15244,15797,15533],0); -ELEMENTS[70397] = Fluid3D([15797,15936,15533,15840],0); -ELEMENTS[70398] = Fluid3D([6677,6619,6261,5830],0); -ELEMENTS[70399] = Fluid3D([6261,6677,5830,6388],0); -ELEMENTS[70400] = Fluid3D([5830,6261,6388,5759],0); -ELEMENTS[70401] = Fluid3D([12251,13126,12932,12310],0); -ELEMENTS[70402] = Fluid3D([13599,13943,14351,13177],0); -ELEMENTS[70403] = Fluid3D([2628,2736,2960,3314],0); -ELEMENTS[70404] = Fluid3D([5751,5113,5658,5242],0); -ELEMENTS[70405] = Fluid3D([7588,6888,7284,7818],0); -ELEMENTS[70406] = Fluid3D([7284,7588,7818,8505],0); -ELEMENTS[70407] = Fluid3D([9665,9179,9126,8815],0); -ELEMENTS[70408] = Fluid3D([9665,9179,8815,8686],0); -ELEMENTS[70409] = Fluid3D([16297,16437,16069,15517],0); -ELEMENTS[70410] = Fluid3D([10268,9928,10087,9476],0); -ELEMENTS[70411] = Fluid3D([10268,9928,9476,9175],0); -ELEMENTS[70412] = Fluid3D([4825,4487,4886,5222],0); -ELEMENTS[70413] = Fluid3D([7775,8598,8148,8367],0); -ELEMENTS[70414] = Fluid3D([11851,12515,11903,12765],0); -ELEMENTS[70415] = Fluid3D([17834,17751,17378,17658],0); -ELEMENTS[70416] = Fluid3D([17834,17751,17658,18066],0); -ELEMENTS[70417] = Fluid3D([18094,18210,18260,18401],0); -ELEMENTS[70418] = Fluid3D([6183,5924,5704,5694],0); -ELEMENTS[70419] = Fluid3D([6183,5924,5694,6689],0); -ELEMENTS[70420] = Fluid3D([2019,1919,1989,1870],0); -ELEMENTS[70421] = Fluid3D([1919,1989,1870,1785],0); -ELEMENTS[70422] = Fluid3D([16347,16652,16311,15893],0); -ELEMENTS[70423] = Fluid3D([15441,14859,15705,14941],0); -ELEMENTS[70424] = Fluid3D([15308,14962,15338,15840],0); -ELEMENTS[70425] = Fluid3D([11572,11002,11779,12032],0); -ELEMENTS[70426] = Fluid3D([17221,17011,17622,17267],0); -ELEMENTS[70427] = Fluid3D([17221,17011,17267,17333],0); -ELEMENTS[70428] = Fluid3D([18110,18201,17971,17961],0); -ELEMENTS[70429] = Fluid3D([1933,1906,2046,2179],0); -ELEMENTS[70430] = Fluid3D([15871,16227,16231,16591],0); -ELEMENTS[70431] = Fluid3D([8055,8785,7970,7776],0); -ELEMENTS[70432] = Fluid3D([16446,16457,16195,16862],0); -ELEMENTS[70433] = Fluid3D([16195,16446,16862,16693],0); -ELEMENTS[70434] = Fluid3D([16446,16862,16693,17040],0); -ELEMENTS[70435] = Fluid3D([16862,16195,16693,16457],0); -ELEMENTS[70436] = Fluid3D([16698,17177,16581,16915],0); -ELEMENTS[70437] = Fluid3D([5174,5809,5087,4893],0); -ELEMENTS[70438] = Fluid3D([5087,5174,4893,4654],0); -ELEMENTS[70439] = Fluid3D([15269,14868,14564,15474],0); -ELEMENTS[70440] = Fluid3D([3669,3945,4350,3770],0); -ELEMENTS[70441] = Fluid3D([3669,3945,3770,3738],0); -ELEMENTS[70442] = Fluid3D([10130,10476,10928,9560],0); -ELEMENTS[70443] = Fluid3D([7955,8354,7128,7612],0); -ELEMENTS[70444] = Fluid3D([5055,5288,5964,5222],0); -ELEMENTS[70445] = Fluid3D([16379,16438,16002,16425],0); -ELEMENTS[70446] = Fluid3D([9602,10029,9583,9109],0); -ELEMENTS[70447] = Fluid3D([12816,12804,12004,11699],0); -ELEMENTS[70448] = Fluid3D([12804,12004,11699,11708],0); -ELEMENTS[70449] = Fluid3D([10907,9992,10424,10405],0); -ELEMENTS[70450] = Fluid3D([9070,8169,8416,8333],0); -ELEMENTS[70451] = Fluid3D([5811,6300,5712,6075],0); -ELEMENTS[70452] = Fluid3D([6970,6741,6468,7283],0); -ELEMENTS[70453] = Fluid3D([8146,8186,7977,7221],0); -ELEMENTS[70454] = Fluid3D([12114,12310,11458,10960],0); -ELEMENTS[70455] = Fluid3D([1727,1752,1807,1659],0); -ELEMENTS[70456] = Fluid3D([5790,5616,6004,5144],0); -ELEMENTS[70457] = Fluid3D([5616,6004,5144,5560],0); -ELEMENTS[70458] = Fluid3D([16159,16313,16868,16541],0); -ELEMENTS[70459] = Fluid3D([16159,16313,16541,16044],0); -ELEMENTS[70460] = Fluid3D([3511,3440,3009,3156],0); -ELEMENTS[70461] = Fluid3D([4175,4727,4441,3919],0); -ELEMENTS[70462] = Fluid3D([7578,7486,7043,6637],0); -ELEMENTS[70463] = Fluid3D([7486,7043,6637,7495],0); -ELEMENTS[70464] = Fluid3D([7578,7486,6637,7264],0); -ELEMENTS[70465] = Fluid3D([8133,8710,8860,8758],0); -ELEMENTS[70466] = Fluid3D([3752,3376,3666,3550],0); -ELEMENTS[70467] = Fluid3D([15118,15621,15328,15863],0); -ELEMENTS[70468] = Fluid3D([18254,18346,18500,18490],0); -ELEMENTS[70469] = Fluid3D([12682,12293,13650,13378],0); -ELEMENTS[70470] = Fluid3D([17461,17686,17941,17735],0); -ELEMENTS[70471] = Fluid3D([18227,18137,18221,18059],0); -ELEMENTS[70472] = Fluid3D([18227,18137,18059,17770],0); -ELEMENTS[70473] = Fluid3D([2665,2890,2469,2649],0); -ELEMENTS[70474] = Fluid3D([7310,6806,8065,7976],0); -ELEMENTS[70475] = Fluid3D([8065,7310,7976,7850],0); -ELEMENTS[70476] = Fluid3D([12153,12667,12528,11701],0); -ELEMENTS[70477] = Fluid3D([2813,3038,3214,3158],0); -ELEMENTS[70478] = Fluid3D([3038,3214,3158,3480],0); -ELEMENTS[70479] = Fluid3D([3158,3038,3480,3135],0); -ELEMENTS[70480] = Fluid3D([2578,2528,2350,2264],0); -ELEMENTS[70481] = Fluid3D([2528,2350,2264,2207],0); -ELEMENTS[70482] = Fluid3D([15451,14885,14977,15303],0); -ELEMENTS[70483] = Fluid3D([3015,2650,2812,3159],0); -ELEMENTS[70484] = Fluid3D([2812,3015,3159,3210],0); -ELEMENTS[70485] = Fluid3D([2812,3015,3210,3314],0); -ELEMENTS[70486] = Fluid3D([1828,1807,1888,1752],0); -ELEMENTS[70487] = Fluid3D([8302,7364,7581,7082],0); -ELEMENTS[70488] = Fluid3D([9483,10001,8927,9822],0); -ELEMENTS[70489] = Fluid3D([17626,17986,17845,17536],0); -ELEMENTS[70490] = Fluid3D([18633,18580,18566,18527],0); -ELEMENTS[70491] = Fluid3D([5928,6726,6229,7114],0); -ELEMENTS[70492] = Fluid3D([7189,7543,6821,6449],0); -ELEMENTS[70493] = Fluid3D([7189,7543,6449,7124],0); -ELEMENTS[70494] = Fluid3D([7189,7543,7124,7880],0); -ELEMENTS[70495] = Fluid3D([8323,8648,7844,7418],0); -ELEMENTS[70496] = Fluid3D([11386,11321,10218,11187],0); -ELEMENTS[70497] = Fluid3D([7326,7024,7272,7832],0); -ELEMENTS[70498] = Fluid3D([14683,14838,15176,14243],0); -ELEMENTS[70499] = Fluid3D([9486,10034,10577,9002],0); -ELEMENTS[70500] = Fluid3D([9495,10459,10471,9471],0); -ELEMENTS[70501] = Fluid3D([13699,13518,14262,14717],0); -ELEMENTS[70502] = Fluid3D([2742,2450,2718,2493],0); -ELEMENTS[70503] = Fluid3D([12232,11771,11921,12727],0); -ELEMENTS[70504] = Fluid3D([5940,6243,6227,6458],0); -ELEMENTS[70505] = Fluid3D([6920,6988,7717,7489],0); -ELEMENTS[70506] = Fluid3D([6920,6988,7489,7025],0); -ELEMENTS[70507] = Fluid3D([8027,8272,7328,7123],0); -ELEMENTS[70508] = Fluid3D([11852,11233,10976,10634],0); -ELEMENTS[70509] = Fluid3D([8797,8691,7795,7781],0); -ELEMENTS[70510] = Fluid3D([16235,16311,15935,15643],0); -ELEMENTS[70511] = Fluid3D([16311,15935,15643,15973],0); -ELEMENTS[70512] = Fluid3D([6390,6330,5612,5717],0); -ELEMENTS[70513] = Fluid3D([3878,3869,4375,3922],0); -ELEMENTS[70514] = Fluid3D([4139,4000,4067,3503],0); -ELEMENTS[70515] = Fluid3D([9262,8962,10110,10309],0); -ELEMENTS[70516] = Fluid3D([9262,8962,10309,9884],0); -ELEMENTS[70517] = Fluid3D([8395,7588,8505,7818],0); -ELEMENTS[70518] = Fluid3D([5819,5911,5873,6542],0); -ELEMENTS[70519] = Fluid3D([4219,4261,4389,3839],0); -ELEMENTS[70520] = Fluid3D([4219,4261,3839,4467],0); -ELEMENTS[70521] = Fluid3D([4133,3763,4352,4441],0); -ELEMENTS[70522] = Fluid3D([2482,2602,2257,2464],0); -ELEMENTS[70523] = Fluid3D([8935,9214,8052,9013],0); -ELEMENTS[70524] = Fluid3D([16705,16535,16704,15986],0); -ELEMENTS[70525] = Fluid3D([16784,17086,16593,17276],0); -ELEMENTS[70526] = Fluid3D([4793,5298,5566,5258],0); -ELEMENTS[70527] = Fluid3D([6899,6527,7647,7517],0); -ELEMENTS[70528] = Fluid3D([13434,12939,13411,12910],0); -ELEMENTS[70529] = Fluid3D([18082,18331,18260,18380],0); -ELEMENTS[70530] = Fluid3D([5313,4983,5613,5754],0); -ELEMENTS[70531] = Fluid3D([9613,9294,10131,10207],0); -ELEMENTS[70532] = Fluid3D([4145,3840,3986,4089],0); -ELEMENTS[70533] = Fluid3D([6739,6346,5777,6528],0); -ELEMENTS[70534] = Fluid3D([5139,5695,5507,4949],0); -ELEMENTS[70535] = Fluid3D([9321,9852,8643,9358],0); -ELEMENTS[70536] = Fluid3D([18114,18313,18062,18067],0); -ELEMENTS[70537] = Fluid3D([16695,16649,17003,17165],0); -ELEMENTS[70538] = Fluid3D([12996,12212,13246,12984],0); -ELEMENTS[70539] = Fluid3D([13246,12996,12984,13765],0); -ELEMENTS[70540] = Fluid3D([12996,12212,12984,13765],0); -ELEMENTS[70541] = Fluid3D([15132,15656,15752,15447],0); -ELEMENTS[70542] = Fluid3D([10580,11549,11232,10461],0); -ELEMENTS[70543] = Fluid3D([6061,6229,5531,5848],0); -ELEMENTS[70544] = Fluid3D([11927,12125,11849,10869],0); -ELEMENTS[70545] = Fluid3D([15184,15682,14956,15223],0); -ELEMENTS[70546] = Fluid3D([2401,2493,2497,2248],0); -ELEMENTS[70547] = Fluid3D([2401,2493,2248,2233],0); -ELEMENTS[70548] = Fluid3D([2401,2493,2233,2598],0); -ELEMENTS[70549] = Fluid3D([17483,17416,17494,17790],0); -ELEMENTS[70550] = Fluid3D([7622,7826,6900,7644],0); -ELEMENTS[70551] = Fluid3D([7622,7826,7644,8789],0); -ELEMENTS[70552] = Fluid3D([16088,15814,15849,16590],0); -ELEMENTS[70553] = Fluid3D([3036,3200,3248,2792],0); -ELEMENTS[70554] = Fluid3D([3200,3248,2792,3182],0); -ELEMENTS[70555] = Fluid3D([2792,3200,3182,2828],0); -ELEMENTS[70556] = Fluid3D([3200,3182,2828,3036],0); -ELEMENTS[70557] = Fluid3D([3200,3248,3182,3797],0); -ELEMENTS[70558] = Fluid3D([15403,14930,14641,14548],0); -ELEMENTS[70559] = Fluid3D([3254,3181,3646,3223],0); -ELEMENTS[70560] = Fluid3D([13647,14184,14487,14430],0); -ELEMENTS[70561] = Fluid3D([10867,10752,10556,11615],0); -ELEMENTS[70562] = Fluid3D([10867,10752,11615,11716],0); -ELEMENTS[70563] = Fluid3D([11615,10867,11716,12427],0); -ELEMENTS[70564] = Fluid3D([10752,11615,11716,12419],0); -ELEMENTS[70565] = Fluid3D([11615,11716,12419,12427],0); -ELEMENTS[70566] = Fluid3D([10752,10556,11615,11975],0); -ELEMENTS[70567] = Fluid3D([11615,10752,11975,11666],0); -ELEMENTS[70568] = Fluid3D([16303,16747,16881,16749],0); -ELEMENTS[70569] = Fluid3D([15019,14561,14437,15015],0); -ELEMENTS[70570] = Fluid3D([15019,14561,15015,15617],0); -ELEMENTS[70571] = Fluid3D([4849,4473,5152,4469],0); -ELEMENTS[70572] = Fluid3D([11215,10282,10408,9724],0); -ELEMENTS[70573] = Fluid3D([6157,6329,5743,5787],0); -ELEMENTS[70574] = Fluid3D([5478,5068,5603,5331],0); -ELEMENTS[70575] = Fluid3D([12209,13144,13185,12327],0); -ELEMENTS[70576] = Fluid3D([2116,2064,2340,2075],0); -ELEMENTS[70577] = Fluid3D([2116,2064,2075,1919],0); -ELEMENTS[70578] = Fluid3D([11234,11682,12282,11866],0); -ELEMENTS[70579] = Fluid3D([4880,5124,5443,5822],0); -ELEMENTS[70580] = Fluid3D([14994,15261,15739,15049],0); -ELEMENTS[70581] = Fluid3D([6164,5498,5917,5841],0); -ELEMENTS[70582] = Fluid3D([11788,11188,11489,12186],0); -ELEMENTS[70583] = Fluid3D([11375,11011,11995,10803],0); -ELEMENTS[70584] = Fluid3D([8410,8653,9084,8452],0); -ELEMENTS[70585] = Fluid3D([16405,16706,16002,15971],0); -ELEMENTS[70586] = Fluid3D([1888,1752,2018,1812],0); -ELEMENTS[70587] = Fluid3D([4243,4103,4821,4407],0); -ELEMENTS[70588] = Fluid3D([17481,17467,17224,17087],0); -ELEMENTS[70589] = Fluid3D([9999,9328,10048,9696],0); -ELEMENTS[70590] = Fluid3D([9999,9328,9696,8622],0); -ELEMENTS[70591] = Fluid3D([7367,8058,8245,8655],0); -ELEMENTS[70592] = Fluid3D([13999,13276,14275,13518],0); -ELEMENTS[70593] = Fluid3D([5993,5805,5808,5118],0); -ELEMENTS[70594] = Fluid3D([13881,14614,14123,14772],0); -ELEMENTS[70595] = Fluid3D([13881,14614,14772,13954],0); -ELEMENTS[70596] = Fluid3D([2715,2705,3122,2995],0); -ELEMENTS[70597] = Fluid3D([15724,15728,14881,15222],0); -ELEMENTS[70598] = Fluid3D([11849,12125,12191,11346],0); -ELEMENTS[70599] = Fluid3D([10432,9911,10372,11118],0); -ELEMENTS[70600] = Fluid3D([5234,5171,5747,5045],0); -ELEMENTS[70601] = Fluid3D([5234,5171,5045,4375],0); -ELEMENTS[70602] = Fluid3D([18468,18390,18392,18191],0); -ELEMENTS[70603] = Fluid3D([10743,10098,9680,10373],0); -ELEMENTS[70604] = Fluid3D([14422,14014,14063,14445],0); -ELEMENTS[70605] = Fluid3D([17254,16935,17540,17473],0); -ELEMENTS[70606] = Fluid3D([18198,18123,17951,17786],0); -ELEMENTS[70607] = Fluid3D([6812,6496,7308,6750],0); -ELEMENTS[70608] = Fluid3D([10156,9832,10851,10494],0); -ELEMENTS[70609] = Fluid3D([6982,7447,7244,7757],0); -ELEMENTS[70610] = Fluid3D([17514,17756,17888,17770],0); -ELEMENTS[70611] = Fluid3D([18158,18237,18409,18266],0); -ELEMENTS[70612] = Fluid3D([11280,10951,11007,11872],0); -ELEMENTS[70613] = Fluid3D([5286,5946,5548,4888],0); -ELEMENTS[70614] = Fluid3D([16543,16710,17034,16606],0); -ELEMENTS[70615] = Fluid3D([8772,7953,8666,8968],0); -ELEMENTS[70616] = Fluid3D([5545,5340,5205,5576],0); -ELEMENTS[70617] = Fluid3D([11899,11448,11475,11095],0); -ELEMENTS[70618] = Fluid3D([10467,10672,11077,11433],0); -ELEMENTS[70619] = Fluid3D([10467,10672,11433,11230],0); -ELEMENTS[70620] = Fluid3D([11077,10467,11433,10818],0); -ELEMENTS[70621] = Fluid3D([17919,17649,18002,17883],0); -ELEMENTS[70622] = Fluid3D([11118,11447,10407,10109],0); -ELEMENTS[70623] = Fluid3D([17083,17388,17271,17428],0); -ELEMENTS[70624] = Fluid3D([9780,9965,10817,10845],0); -ELEMENTS[70625] = Fluid3D([15217,15655,15652,16077],0); -ELEMENTS[70626] = Fluid3D([12746,12112,12962,12696],0); -ELEMENTS[70627] = Fluid3D([4165,3818,4027,4279],0); -ELEMENTS[70628] = Fluid3D([4839,5137,4777,5304],0); -ELEMENTS[70629] = Fluid3D([12206,11801,12575,13099],0); -ELEMENTS[70630] = Fluid3D([10229,10065,10873,11080],0); -ELEMENTS[70631] = Fluid3D([10229,10065,11080,10664],0); -ELEMENTS[70632] = Fluid3D([11080,10229,10664,10339],0); -ELEMENTS[70633] = Fluid3D([11080,10229,10339,10969],0); -ELEMENTS[70634] = Fluid3D([4743,4621,4791,4215],0); -ELEMENTS[70635] = Fluid3D([15313,16053,15683,15545],0); -ELEMENTS[70636] = Fluid3D([9295,9148,9257,10390],0); -ELEMENTS[70637] = Fluid3D([7511,7579,7597,6636],0); -ELEMENTS[70638] = Fluid3D([16408,15682,15807,16299],0); -ELEMENTS[70639] = Fluid3D([3329,3434,3844,3984],0); -ELEMENTS[70640] = Fluid3D([9404,9325,10225,10374],0); -ELEMENTS[70641] = Fluid3D([15233,15079,14674,14514],0); -ELEMENTS[70642] = Fluid3D([1939,1964,1976,2186],0); -ELEMENTS[70643] = Fluid3D([2170,2062,2203,2419],0); -ELEMENTS[70644] = Fluid3D([10812,11080,10969,10229],0); -ELEMENTS[70645] = Fluid3D([10812,11080,10229,10873],0); -ELEMENTS[70646] = Fluid3D([13899,13537,13183,13877],0); -ELEMENTS[70647] = Fluid3D([17716,17793,17420,17367],0); -ELEMENTS[70648] = Fluid3D([11474,11542,10666,10004],0); -ELEMENTS[70649] = Fluid3D([10528,11020,9781,10106],0); -ELEMENTS[70650] = Fluid3D([10528,11020,10106,10531],0); -ELEMENTS[70651] = Fluid3D([11020,10106,10531,9464],0); -ELEMENTS[70652] = Fluid3D([10106,10531,9464,9852],0); -ELEMENTS[70653] = Fluid3D([10106,10531,9852,10528],0); -ELEMENTS[70654] = Fluid3D([9464,10106,9852,9781],0); -ELEMENTS[70655] = Fluid3D([9464,10106,9781,11020],0); -ELEMENTS[70656] = Fluid3D([9852,10106,10528,9781],0); -ELEMENTS[70657] = Fluid3D([10531,9464,9852,9358],0); -ELEMENTS[70658] = Fluid3D([8889,9072,8330,7892],0); -ELEMENTS[70659] = Fluid3D([4037,4278,4241,4774],0); -ELEMENTS[70660] = Fluid3D([4113,4483,4160,3874],0); -ELEMENTS[70661] = Fluid3D([8709,9170,10009,9925],0); -ELEMENTS[70662] = Fluid3D([9170,10009,9925,9108],0); -ELEMENTS[70663] = Fluid3D([9925,9170,9108,8979],0); -ELEMENTS[70664] = Fluid3D([9170,10009,9108,9853],0); -ELEMENTS[70665] = Fluid3D([14412,13405,14100,13400],0); -ELEMENTS[70666] = Fluid3D([13405,14100,13400,12973],0); -ELEMENTS[70667] = Fluid3D([15287,15781,15534,16129],0); -ELEMENTS[70668] = Fluid3D([13706,13086,12916,12636],0); -ELEMENTS[70669] = Fluid3D([13086,12916,12636,12172],0); -ELEMENTS[70670] = Fluid3D([13034,12260,12468,13575],0); -ELEMENTS[70671] = Fluid3D([15934,16302,15654,16374],0); -ELEMENTS[70672] = Fluid3D([4141,4036,4059,4589],0); -ELEMENTS[70673] = Fluid3D([12677,13051,12261,12224],0); -ELEMENTS[70674] = Fluid3D([10576,11086,11059,10753],0); -ELEMENTS[70675] = Fluid3D([5295,5251,5761,5022],0); -ELEMENTS[70676] = Fluid3D([10061,10386,9659,10541],0); -ELEMENTS[70677] = Fluid3D([18106,17919,18002,17883],0); -ELEMENTS[70678] = Fluid3D([9131,9152,8487,8327],0); -ELEMENTS[70679] = Fluid3D([9152,8487,8327,7791],0); -ELEMENTS[70680] = Fluid3D([9131,9152,8327,8970],0); -ELEMENTS[70681] = Fluid3D([9152,8327,8970,7791],0); -ELEMENTS[70682] = Fluid3D([8487,9131,8327,7595],0); -ELEMENTS[70683] = Fluid3D([8327,8487,7595,7791],0); -ELEMENTS[70684] = Fluid3D([7595,8327,7791,7909],0); -ELEMENTS[70685] = Fluid3D([7595,8327,7909,9131],0); -ELEMENTS[70686] = Fluid3D([8327,7909,9131,8970],0); -ELEMENTS[70687] = Fluid3D([8327,7909,8970,7791],0); -ELEMENTS[70688] = Fluid3D([14538,14457,15278,14772],0); -ELEMENTS[70689] = Fluid3D([2078,1999,2041,2215],0); -ELEMENTS[70690] = Fluid3D([3928,3660,3544,4287],0); -ELEMENTS[70691] = Fluid3D([8634,7850,7776,8065],0); -ELEMENTS[70692] = Fluid3D([15287,14853,15723,15397],0); -ELEMENTS[70693] = Fluid3D([2507,2831,2590,2788],0); -ELEMENTS[70694] = Fluid3D([17979,17884,18012,17664],0); -ELEMENTS[70695] = Fluid3D([13460,13857,13827,14557],0); -ELEMENTS[70696] = Fluid3D([10630,11042,9985,10928],0); -ELEMENTS[70697] = Fluid3D([9955,10967,10695,10134],0); -ELEMENTS[70698] = Fluid3D([3367,3204,3224,3660],0); -ELEMENTS[70699] = Fluid3D([18134,17804,17919,18106],0); -ELEMENTS[70700] = Fluid3D([10601,10401,10790,11687],0); -ELEMENTS[70701] = Fluid3D([10790,10601,11687,10699],0); -ELEMENTS[70702] = Fluid3D([18223,18192,18132,18332],0); -ELEMENTS[70703] = Fluid3D([6788,7629,6879,7392],0); -ELEMENTS[70704] = Fluid3D([10539,9601,10221,9712],0); -ELEMENTS[70705] = Fluid3D([17962,18068,17867,17633],0); -ELEMENTS[70706] = Fluid3D([2152,2037,2009,1915],0); -ELEMENTS[70707] = Fluid3D([18553,18630,18595,18565],0); -ELEMENTS[70708] = Fluid3D([18553,18630,18565,18624],0); -ELEMENTS[70709] = Fluid3D([14516,13903,13775,13366],0); -ELEMENTS[70710] = Fluid3D([17508,16989,17371,17144],0); -ELEMENTS[70711] = Fluid3D([12949,13755,13866,13851],0); -ELEMENTS[70712] = Fluid3D([16873,16523,16816,16251],0); -ELEMENTS[70713] = Fluid3D([2234,2167,2034,1948],0); -ELEMENTS[70714] = Fluid3D([2234,2167,1948,1955],0); -ELEMENTS[70715] = Fluid3D([3446,3527,3154,3040],0); -ELEMENTS[70716] = Fluid3D([7243,7372,6855,6190],0); -ELEMENTS[70717] = Fluid3D([4490,4039,4206,4129],0); -ELEMENTS[70718] = Fluid3D([3138,2978,3320,2928],0); -ELEMENTS[70719] = Fluid3D([16576,16551,16155,16683],0); -ELEMENTS[70720] = Fluid3D([12865,13669,12690,12405],0); -ELEMENTS[70721] = Fluid3D([10169,10927,9530,10354],0); -ELEMENTS[70722] = Fluid3D([7932,7816,7919,8508],0); -ELEMENTS[70723] = Fluid3D([11212,10861,10288,11638],0); -ELEMENTS[70724] = Fluid3D([8634,8590,7970,8790],0); -ELEMENTS[70725] = Fluid3D([7117,8014,7260,7852],0); -ELEMENTS[70726] = Fluid3D([13172,13410,12522,13311],0); -ELEMENTS[70727] = Fluid3D([3205,3570,3104,3219],0); -ELEMENTS[70728] = Fluid3D([11987,11955,13004,12156],0); -ELEMENTS[70729] = Fluid3D([16563,16313,16454,16541],0); -ELEMENTS[70730] = Fluid3D([5556,5225,5419,5077],0); -ELEMENTS[70731] = Fluid3D([5556,5225,5077,4968],0); -ELEMENTS[70732] = Fluid3D([5077,5556,4968,5586],0); -ELEMENTS[70733] = Fluid3D([5077,5556,5586,6068],0); -ELEMENTS[70734] = Fluid3D([5556,5586,6068,5969],0); -ELEMENTS[70735] = Fluid3D([6068,5556,5969,6406],0); -ELEMENTS[70736] = Fluid3D([3290,3148,2978,2727],0); -ELEMENTS[70737] = Fluid3D([14026,14080,13172,13410],0); -ELEMENTS[70738] = Fluid3D([17595,17204,17378,17103],0); -ELEMENTS[70739] = Fluid3D([15438,15858,15757,15954],0); -ELEMENTS[70740] = Fluid3D([17291,17415,17174,17603],0); -ELEMENTS[70741] = Fluid3D([11295,11770,10428,10676],0); -ELEMENTS[70742] = Fluid3D([9689,10001,10921,10826],0); -ELEMENTS[70743] = Fluid3D([14709,14273,14797,14921],0); -ELEMENTS[70744] = Fluid3D([7983,7306,7958,8046],0); -ELEMENTS[70745] = Fluid3D([3429,3825,3942,3878],0); -ELEMENTS[70746] = Fluid3D([12841,12695,11930,12599],0); -ELEMENTS[70747] = Fluid3D([5828,5398,5076,5582],0); -ELEMENTS[70748] = Fluid3D([17888,17918,17756,17550],0); -ELEMENTS[70749] = Fluid3D([14960,15680,15213,15683],0); -ELEMENTS[70750] = Fluid3D([15640,16064,15548,15772],0); -ELEMENTS[70751] = Fluid3D([9797,9816,9089,10120],0); -ELEMENTS[70752] = Fluid3D([17753,17467,17481,17381],0); -ELEMENTS[70753] = Fluid3D([18297,18452,18470,18378],0); -ELEMENTS[70754] = Fluid3D([12695,12219,13133,13233],0); -ELEMENTS[70755] = Fluid3D([11286,10638,10552,11847],0); -ELEMENTS[70756] = Fluid3D([11286,10638,11847,11978],0); -ELEMENTS[70757] = Fluid3D([4101,4264,4684,4743],0); -ELEMENTS[70758] = Fluid3D([18670,18677,18686,18693],0); -ELEMENTS[70759] = Fluid3D([18670,18677,18693,18675],0); -ELEMENTS[70760] = Fluid3D([7446,8257,8294,7344],0); -ELEMENTS[70761] = Fluid3D([12297,12111,11184,11884],0); -ELEMENTS[70762] = Fluid3D([13393,14070,13077,13625],0); -ELEMENTS[70763] = Fluid3D([18528,18596,18571,18414],0); -ELEMENTS[70764] = Fluid3D([6214,6515,7105,6531],0); -ELEMENTS[70765] = Fluid3D([14525,14533,15090,14506],0); -ELEMENTS[70766] = Fluid3D([9597,8648,8379,8608],0); -ELEMENTS[70767] = Fluid3D([13402,13738,13310,12831],0); -ELEMENTS[70768] = Fluid3D([15365,14780,15377,15356],0); -ELEMENTS[70769] = Fluid3D([11316,12165,11051,11890],0); -ELEMENTS[70770] = Fluid3D([7763,7091,8251,7855],0); -ELEMENTS[70771] = Fluid3D([16265,16477,15867,15765],0); -ELEMENTS[70772] = Fluid3D([4294,5087,4654,5107],0); -ELEMENTS[70773] = Fluid3D([5087,4654,5107,5174],0); -ELEMENTS[70774] = Fluid3D([4618,4591,4907,4552],0); -ELEMENTS[70775] = Fluid3D([7621,8190,7189,8353],0); -ELEMENTS[70776] = Fluid3D([8649,8884,7794,7880],0); -ELEMENTS[70777] = Fluid3D([17571,17642,17107,17048],0); -ELEMENTS[70778] = Fluid3D([17558,17895,17715,18113],0); -ELEMENTS[70779] = Fluid3D([5680,5950,5249,5765],0); -ELEMENTS[70780] = Fluid3D([5680,5950,5765,6366],0); -ELEMENTS[70781] = Fluid3D([5765,5680,6366,5515],0); -ELEMENTS[70782] = Fluid3D([5765,5680,5515,5168],0); -ELEMENTS[70783] = Fluid3D([5765,5680,5168,5249],0); -ELEMENTS[70784] = Fluid3D([5680,5515,5168,5249],0); -ELEMENTS[70785] = Fluid3D([7005,6156,6718,6664],0); -ELEMENTS[70786] = Fluid3D([6646,6396,7395,7299],0); -ELEMENTS[70787] = Fluid3D([8125,8806,8156,7616],0); -ELEMENTS[70788] = Fluid3D([4262,4098,3843,3900],0); -ELEMENTS[70789] = Fluid3D([16991,17328,17408,17362],0); -ELEMENTS[70790] = Fluid3D([15719,15705,15428,14859],0); -ELEMENTS[70791] = Fluid3D([10541,9577,10454,9659],0); -ELEMENTS[70792] = Fluid3D([7993,7611,8768,7814],0); -ELEMENTS[70793] = Fluid3D([7993,7611,7814,7508],0); -ELEMENTS[70794] = Fluid3D([7814,7993,7508,8368],0); -ELEMENTS[70795] = Fluid3D([15420,15605,15214,16021],0); -ELEMENTS[70796] = Fluid3D([15605,15214,16021,15904],0); -ELEMENTS[70797] = Fluid3D([17592,17653,17212,17420],0); -ELEMENTS[70798] = Fluid3D([7925,8291,8858,8463],0); -ELEMENTS[70799] = Fluid3D([8858,7925,8463,8217],0); -ELEMENTS[70800] = Fluid3D([7925,8463,8217,7629],0); -ELEMENTS[70801] = Fluid3D([8463,8217,7629,8945],0); -ELEMENTS[70802] = Fluid3D([8463,8217,8945,9177],0); -ELEMENTS[70803] = Fluid3D([8463,8217,9177,8858],0); -ELEMENTS[70804] = Fluid3D([8945,8463,9177,9392],0); -ELEMENTS[70805] = Fluid3D([8945,8463,9392,8291],0); -ELEMENTS[70806] = Fluid3D([8945,8463,8291,7629],0); -ELEMENTS[70807] = Fluid3D([7925,8291,8463,7629],0); -ELEMENTS[70808] = Fluid3D([9177,8463,8858,9392],0); -ELEMENTS[70809] = Fluid3D([8463,8858,9392,8291],0); -ELEMENTS[70810] = Fluid3D([16863,17031,16445,16697],0); -ELEMENTS[70811] = Fluid3D([15626,15085,15976,15802],0); -ELEMENTS[70812] = Fluid3D([10727,10704,11781,11004],0); -ELEMENTS[70813] = Fluid3D([1680,1783,1606,1681],0); -ELEMENTS[70814] = Fluid3D([6885,7467,7775,7981],0); -ELEMENTS[70815] = Fluid3D([10222,10316,10659,9216],0); -ELEMENTS[70816] = Fluid3D([12144,12007,13011,12721],0); -ELEMENTS[70817] = Fluid3D([11799,10897,11851,10561],0); -ELEMENTS[70818] = Fluid3D([12330,11232,11962,11046],0); -ELEMENTS[70819] = Fluid3D([4871,4897,5445,5334],0); -ELEMENTS[70820] = Fluid3D([5886,6307,5905,6162],0); -ELEMENTS[70821] = Fluid3D([13066,13304,12405,13471],0); -ELEMENTS[70822] = Fluid3D([12082,11580,12503,11726],0); -ELEMENTS[70823] = Fluid3D([9295,9296,10390,9257],0); -ELEMENTS[70824] = Fluid3D([9295,9296,9257,8623],0); -ELEMENTS[70825] = Fluid3D([9296,10390,9257,10587],0); -ELEMENTS[70826] = Fluid3D([9295,9296,8623,9549],0); -ELEMENTS[70827] = Fluid3D([15174,15261,14414,15305],0); -ELEMENTS[70828] = Fluid3D([13024,13075,12819,13872],0); -ELEMENTS[70829] = Fluid3D([13075,12819,13872,13575],0); -ELEMENTS[70830] = Fluid3D([13287,13955,14330,14361],0); -ELEMENTS[70831] = Fluid3D([13731,13744,13079,13503],0); -ELEMENTS[70832] = Fluid3D([6173,5852,6316,5601],0); -ELEMENTS[70833] = Fluid3D([6173,5852,5601,5644],0); -ELEMENTS[70834] = Fluid3D([6173,5852,5644,5456],0); -ELEMENTS[70835] = Fluid3D([13506,14354,14421,13315],0); -ELEMENTS[70836] = Fluid3D([5808,5561,5118,5805],0); -ELEMENTS[70837] = Fluid3D([10317,11223,11566,11022],0); -ELEMENTS[70838] = Fluid3D([13964,13716,13484,14403],0); -ELEMENTS[70839] = Fluid3D([11521,10860,12156,11240],0); -ELEMENTS[70840] = Fluid3D([16266,16299,16663,16997],0); -ELEMENTS[70841] = Fluid3D([9560,10130,11028,10928],0); -ELEMENTS[70842] = Fluid3D([11131,11757,10705,10680],0); -ELEMENTS[70843] = Fluid3D([7551,8418,7581,8524],0); -ELEMENTS[70844] = Fluid3D([8473,8749,7841,8913],0); -ELEMENTS[70845] = Fluid3D([7841,8473,8913,8575],0); -ELEMENTS[70846] = Fluid3D([11885,12220,12154,12980],0); -ELEMENTS[70847] = Fluid3D([12154,11885,12980,12750],0); -ELEMENTS[70848] = Fluid3D([14686,14491,14019,14147],0); -ELEMENTS[70849] = Fluid3D([13272,14156,13103,13652],0); -ELEMENTS[70850] = Fluid3D([12461,12120,12094,10795],0); -ELEMENTS[70851] = Fluid3D([6887,7494,6720,6916],0); -ELEMENTS[70852] = Fluid3D([10318,10206,10706,9498],0); -ELEMENTS[70853] = Fluid3D([12889,12312,12010,11442],0); -ELEMENTS[70854] = Fluid3D([6644,6146,5863,6028],0); -ELEMENTS[70855] = Fluid3D([6146,5863,6028,5299],0); -ELEMENTS[70856] = Fluid3D([13069,13612,13366,14046],0); -ELEMENTS[70857] = Fluid3D([13069,13612,14046,13473],0); -ELEMENTS[70858] = Fluid3D([13069,13612,13473,13698],0); -ELEMENTS[70859] = Fluid3D([14699,14324,14557,13857],0); -ELEMENTS[70860] = Fluid3D([14699,14324,13857,14444],0); -ELEMENTS[70861] = Fluid3D([14699,14324,14444,14330],0); -ELEMENTS[70862] = Fluid3D([6952,7856,7919,7665],0); -ELEMENTS[70863] = Fluid3D([4618,4147,4591,4552],0); -ELEMENTS[70864] = Fluid3D([16828,16529,16222,16594],0); -ELEMENTS[70865] = Fluid3D([8076,7696,7188,7079],0); -ELEMENTS[70866] = Fluid3D([11996,11894,11000,10778],0); -ELEMENTS[70867] = Fluid3D([15462,14942,15778,15580],0); -ELEMENTS[70868] = Fluid3D([15778,15462,15580,15968],0); -ELEMENTS[70869] = Fluid3D([15580,15778,15968,16384],0); -ELEMENTS[70870] = Fluid3D([9892,10561,10779,11203],0); -ELEMENTS[70871] = Fluid3D([17045,17406,17080,17251],0); -ELEMENTS[70872] = Fluid3D([7706,7094,7820,7056],0); -ELEMENTS[70873] = Fluid3D([7094,7820,7056,6611],0); -ELEMENTS[70874] = Fluid3D([7056,7094,6611,6286],0); -ELEMENTS[70875] = Fluid3D([7094,6611,6286,6828],0); -ELEMENTS[70876] = Fluid3D([7094,6611,6828,6809],0); -ELEMENTS[70877] = Fluid3D([7094,6611,6809,7820],0); -ELEMENTS[70878] = Fluid3D([7056,7094,6286,7038],0); -ELEMENTS[70879] = Fluid3D([7056,7094,7038,7706],0); -ELEMENTS[70880] = Fluid3D([7094,7038,7706,6697],0); -ELEMENTS[70881] = Fluid3D([7094,6286,7038,6697],0); -ELEMENTS[70882] = Fluid3D([6286,7038,6697,7132],0); -ELEMENTS[70883] = Fluid3D([7038,6697,7132,7706],0); -ELEMENTS[70884] = Fluid3D([7132,7038,7706,7056],0); -ELEMENTS[70885] = Fluid3D([7132,7038,7056,6286],0); -ELEMENTS[70886] = Fluid3D([6286,7094,6828,6697],0); -ELEMENTS[70887] = Fluid3D([6828,6286,6697,5864],0); -ELEMENTS[70888] = Fluid3D([15537,15507,15254,14462],0); -ELEMENTS[70889] = Fluid3D([15693,16109,16360,15831],0); -ELEMENTS[70890] = Fluid3D([9107,9779,8976,9206],0); -ELEMENTS[70891] = Fluid3D([17852,18007,18212,18102],0); -ELEMENTS[70892] = Fluid3D([7675,8052,7610,7250],0); -ELEMENTS[70893] = Fluid3D([11925,11618,12693,12529],0); -ELEMENTS[70894] = Fluid3D([14355,15359,15072,15062],0); -ELEMENTS[70895] = Fluid3D([4069,4502,4772,4755],0); -ELEMENTS[70896] = Fluid3D([12711,13631,13528,13390],0); -ELEMENTS[70897] = Fluid3D([4009,3769,3990,3484],0); -ELEMENTS[70898] = Fluid3D([3769,3990,3484,3553],0); -ELEMENTS[70899] = Fluid3D([6662,7347,7087,7866],0); -ELEMENTS[70900] = Fluid3D([15824,15730,15054,15774],0); -ELEMENTS[70901] = Fluid3D([5179,5345,4746,4580],0); -ELEMENTS[70902] = Fluid3D([4746,5179,4580,4700],0); -ELEMENTS[70903] = Fluid3D([5179,4580,4700,5206],0); -ELEMENTS[70904] = Fluid3D([3894,3489,3490,3814],0); -ELEMENTS[70905] = Fluid3D([12231,11547,11175,11391],0); -ELEMENTS[70906] = Fluid3D([11883,12747,11968,12243],0); -ELEMENTS[70907] = Fluid3D([14465,15062,15254,15537],0); -ELEMENTS[70908] = Fluid3D([2956,2935,3088,3260],0); -ELEMENTS[70909] = Fluid3D([14322,14010,14462,15099],0); -ELEMENTS[70910] = Fluid3D([18559,18539,18445,18467],0); -ELEMENTS[70911] = Fluid3D([4003,3860,3629,3378],0); -ELEMENTS[70912] = Fluid3D([4003,3860,3378,3431],0); -ELEMENTS[70913] = Fluid3D([13750,14577,14066,14769],0); -ELEMENTS[70914] = Fluid3D([8335,8017,7305,7357],0); -ELEMENTS[70915] = Fluid3D([15603,16296,16277,15555],0); -ELEMENTS[70916] = Fluid3D([5995,5610,6189,6008],0); -ELEMENTS[70917] = Fluid3D([5610,6189,6008,5270],0); -ELEMENTS[70918] = Fluid3D([6189,5995,6008,6772],0); -ELEMENTS[70919] = Fluid3D([6008,6189,6772,6738],0); -ELEMENTS[70920] = Fluid3D([14581,13949,14275,13741],0); -ELEMENTS[70921] = Fluid3D([9909,9475,9213,9183],0); -ELEMENTS[70922] = Fluid3D([18534,18347,18470,18536],0); -ELEMENTS[70923] = Fluid3D([2705,2582,3037,3057],0); -ELEMENTS[70924] = Fluid3D([5813,6459,5788,5835],0); -ELEMENTS[70925] = Fluid3D([13809,14751,14231,14583],0); -ELEMENTS[70926] = Fluid3D([17552,17710,17446,17318],0); -ELEMENTS[70927] = Fluid3D([17552,17710,17318,17595],0); -ELEMENTS[70928] = Fluid3D([17710,17446,17318,17495],0); -ELEMENTS[70929] = Fluid3D([17318,17710,17495,17378],0); -ELEMENTS[70930] = Fluid3D([17446,17318,17495,16976],0); -ELEMENTS[70931] = Fluid3D([17318,17495,16976,17378],0); -ELEMENTS[70932] = Fluid3D([16976,17318,17378,17103],0); -ELEMENTS[70933] = Fluid3D([16976,17318,17103,17446],0); -ELEMENTS[70934] = Fluid3D([17318,17378,17103,17595],0); -ELEMENTS[70935] = Fluid3D([17446,17552,17318,17103],0); -ELEMENTS[70936] = Fluid3D([17552,17318,17103,17595],0); -ELEMENTS[70937] = Fluid3D([17318,17710,17378,17595],0); -ELEMENTS[70938] = Fluid3D([14513,14823,14027,13715],0); -ELEMENTS[70939] = Fluid3D([14823,14027,13715,14323],0); -ELEMENTS[70940] = Fluid3D([18315,18289,18443,18117],0); -ELEMENTS[70941] = Fluid3D([6165,6558,6886,6414],0); -ELEMENTS[70942] = Fluid3D([6886,6165,6414,5846],0); -ELEMENTS[70943] = Fluid3D([6165,6414,5846,5869],0); -ELEMENTS[70944] = Fluid3D([10587,10500,10298,11524],0); -ELEMENTS[70945] = Fluid3D([14746,14639,15289,14466],0); -ELEMENTS[70946] = Fluid3D([10488,10447,11277,9936],0); -ELEMENTS[70947] = Fluid3D([5422,5206,5778,4923],0); -ELEMENTS[70948] = Fluid3D([11889,12454,12544,12855],0); -ELEMENTS[70949] = Fluid3D([3801,4182,4204,4035],0); -ELEMENTS[70950] = Fluid3D([13668,14397,14539,13955],0); -ELEMENTS[70951] = Fluid3D([6746,6063,6191,5783],0); -ELEMENTS[70952] = Fluid3D([14787,14170,14266,13929],0); -ELEMENTS[70953] = Fluid3D([13114,13443,12668,13124],0); -ELEMENTS[70954] = Fluid3D([15643,15649,16235,15876],0); -ELEMENTS[70955] = Fluid3D([16839,17239,17045,17540],0); -ELEMENTS[70956] = Fluid3D([2840,3062,3381,3112],0); -ELEMENTS[70957] = Fluid3D([17326,17531,17776,17548],0); -ELEMENTS[70958] = Fluid3D([11269,10515,10718,10603],0); -ELEMENTS[70959] = Fluid3D([17461,17784,17681,17941],0); -ELEMENTS[70960] = Fluid3D([16227,16456,16231,16591],0); -ELEMENTS[70961] = Fluid3D([16227,16456,16591,16893],0); -ELEMENTS[70962] = Fluid3D([11588,12087,11272,11897],0); -ELEMENTS[70963] = Fluid3D([9882,10467,10818,11397],0); -ELEMENTS[70964] = Fluid3D([10456,10844,9959,10277],0); -ELEMENTS[70965] = Fluid3D([10456,10844,10277,11509],0); -ELEMENTS[70966] = Fluid3D([9820,10314,9220,10058],0); -ELEMENTS[70967] = Fluid3D([13754,14027,14513,14858],0); -ELEMENTS[70968] = Fluid3D([8439,9187,8891,9690],0); -ELEMENTS[70969] = Fluid3D([8891,8439,9690,9064],0); -ELEMENTS[70970] = Fluid3D([3369,3351,2964,3357],0); -ELEMENTS[70971] = Fluid3D([5244,4964,5106,4742],0); -ELEMENTS[70972] = Fluid3D([13377,12835,13853,13238],0); -ELEMENTS[70973] = Fluid3D([11556,11074,11050,12008],0); -ELEMENTS[70974] = Fluid3D([11074,11050,12008,12072],0); -ELEMENTS[70975] = Fluid3D([12008,11074,12072,12498],0); -ELEMENTS[70976] = Fluid3D([12072,12008,12498,12433],0); -ELEMENTS[70977] = Fluid3D([12072,12008,12433,11050],0); -ELEMENTS[70978] = Fluid3D([12008,12433,11050,11556],0); -ELEMENTS[70979] = Fluid3D([12008,12498,12433,12457],0); -ELEMENTS[70980] = Fluid3D([12433,12008,12457,11556],0); -ELEMENTS[70981] = Fluid3D([12008,12457,11556,12498],0); -ELEMENTS[70982] = Fluid3D([12008,11074,12498,11556],0); -ELEMENTS[70983] = Fluid3D([16729,16623,16213,16582],0); -ELEMENTS[70984] = Fluid3D([4427,3986,4089,4145],0); -ELEMENTS[70985] = Fluid3D([16808,17193,17110,17201],0); -ELEMENTS[70986] = Fluid3D([5455,5106,5858,5748],0); -ELEMENTS[70987] = Fluid3D([6860,6192,6524,6779],0); -ELEMENTS[70988] = Fluid3D([11147,11327,12187,11117],0); -ELEMENTS[70989] = Fluid3D([13309,12816,13851,13049],0); -ELEMENTS[70990] = Fluid3D([13851,13309,13049,13142],0); -ELEMENTS[70991] = Fluid3D([7681,8066,8815,8226],0); -ELEMENTS[70992] = Fluid3D([9636,9690,9187,10404],0); -ELEMENTS[70993] = Fluid3D([10371,10803,11675,10770],0); -ELEMENTS[70994] = Fluid3D([17923,17998,17864,17705],0); -ELEMENTS[70995] = Fluid3D([17998,17864,17705,18095],0); -ELEMENTS[70996] = Fluid3D([13577,13571,14300,14308],0); -ELEMENTS[70997] = Fluid3D([13296,13550,12799,12520],0); -ELEMENTS[70998] = Fluid3D([11952,12268,12273,13334],0); -ELEMENTS[70999] = Fluid3D([14916,15341,15530,15616],0); -ELEMENTS[71000] = Fluid3D([4825,4886,5548,5222],0); -ELEMENTS[71001] = Fluid3D([16123,16544,15701,16263],0); -ELEMENTS[71002] = Fluid3D([16123,16544,16263,16968],0); -ELEMENTS[71003] = Fluid3D([3902,3763,4352,3723],0); -ELEMENTS[71004] = Fluid3D([3902,3763,3723,3356],0); -ELEMENTS[71005] = Fluid3D([3902,3763,3356,3460],0); -ELEMENTS[71006] = Fluid3D([1759,1671,1693,1803],0); -ELEMENTS[71007] = Fluid3D([1759,1671,1803,1746],0); -ELEMENTS[71008] = Fluid3D([7460,7107,7778,8415],0); -ELEMENTS[71009] = Fluid3D([13410,13535,12384,13313],0); -ELEMENTS[71010] = Fluid3D([13410,13535,13313,14427],0); -ELEMENTS[71011] = Fluid3D([4989,5282,4741,5603],0); -ELEMENTS[71012] = Fluid3D([16399,16594,16009,16531],0); -ELEMENTS[71013] = Fluid3D([3169,2935,3497,3260],0); -ELEMENTS[71014] = Fluid3D([3497,3169,3260,3473],0); -ELEMENTS[71015] = Fluid3D([6738,6263,6152,5974],0); -ELEMENTS[71016] = Fluid3D([6738,6263,5974,6460],0); -ELEMENTS[71017] = Fluid3D([2465,2538,2606,2927],0); -ELEMENTS[71018] = Fluid3D([9216,10051,8925,9589],0); -ELEMENTS[71019] = Fluid3D([15480,15816,16300,15297],0); -ELEMENTS[71020] = Fluid3D([11770,11295,10422,10676],0); -ELEMENTS[71021] = Fluid3D([10556,10449,10752,10014],0); -ELEMENTS[71022] = Fluid3D([7511,7347,6636,6662],0); -ELEMENTS[71023] = Fluid3D([6636,7511,6662,7777],0); -ELEMENTS[71024] = Fluid3D([14553,14441,14834,15206],0); -ELEMENTS[71025] = Fluid3D([14553,14441,15206,14768],0); -ELEMENTS[71026] = Fluid3D([4061,4053,4508,4135],0); -ELEMENTS[71027] = Fluid3D([4061,4053,4135,3546],0); -ELEMENTS[71028] = Fluid3D([12715,12936,13395,13905],0); -ELEMENTS[71029] = Fluid3D([3176,3036,2920,2701],0); -ELEMENTS[71030] = Fluid3D([13651,13727,13425,12937],0); -ELEMENTS[71031] = Fluid3D([13651,13727,12937,13275],0); -ELEMENTS[71032] = Fluid3D([3409,3603,3040,3527],0); -ELEMENTS[71033] = Fluid3D([3409,3603,3527,3818],0); -ELEMENTS[71034] = Fluid3D([18359,18145,18188,18403],0); -ELEMENTS[71035] = Fluid3D([14334,14044,14389,13765],0); -ELEMENTS[71036] = Fluid3D([8009,8500,7509,7605],0); -ELEMENTS[71037] = Fluid3D([4662,4580,4361,5206],0); -ELEMENTS[71038] = Fluid3D([14805,15484,14752,15120],0); -ELEMENTS[71039] = Fluid3D([7086,7351,7539,6462],0); -ELEMENTS[71040] = Fluid3D([3770,3669,3738,3308],0); -ELEMENTS[71041] = Fluid3D([3741,3260,3473,3799],0); -ELEMENTS[71042] = Fluid3D([14493,14216,15160,14389],0); -ELEMENTS[71043] = Fluid3D([17179,17281,17477,17160],0); -ELEMENTS[71044] = Fluid3D([13694,13147,13533,12605],0); -ELEMENTS[71045] = Fluid3D([12107,11497,10814,11298],0); -ELEMENTS[71046] = Fluid3D([8665,8808,9860,9102],0); -ELEMENTS[71047] = Fluid3D([13459,14121,14295,13866],0); -ELEMENTS[71048] = Fluid3D([4052,3814,3810,4044],0); -ELEMENTS[71049] = Fluid3D([12368,13042,12599,12363],0); -ELEMENTS[71050] = Fluid3D([15500,14694,14727,15355],0); -ELEMENTS[71051] = Fluid3D([14694,14727,15355,14357],0); -ELEMENTS[71052] = Fluid3D([3179,3116,3600,3450],0); -ELEMENTS[71053] = Fluid3D([3861,4142,3579,3962],0); -ELEMENTS[71054] = Fluid3D([15941,16334,15705,15441],0); -ELEMENTS[71055] = Fluid3D([15705,15941,15441,15777],0); -ELEMENTS[71056] = Fluid3D([8161,8125,7167,8429],0); -ELEMENTS[71057] = Fluid3D([2644,2904,2748,2638],0); -ELEMENTS[71058] = Fluid3D([18547,18572,18619,18594],0); -ELEMENTS[71059] = Fluid3D([8996,9070,8169,8817],0); -ELEMENTS[71060] = Fluid3D([13415,13445,12678,13596],0); -ELEMENTS[71061] = Fluid3D([8165,7962,7608,7376],0); -ELEMENTS[71062] = Fluid3D([8165,7962,7376,8049],0); -ELEMENTS[71063] = Fluid3D([18131,17925,18121,18306],0); -ELEMENTS[71064] = Fluid3D([17546,17501,17450,17216],0); -ELEMENTS[71065] = Fluid3D([17450,17546,17216,17814],0); -ELEMENTS[71066] = Fluid3D([9471,9678,8981,8790],0); -ELEMENTS[71067] = Fluid3D([9471,9678,8790,9495],0); -ELEMENTS[71068] = Fluid3D([18060,18166,18380,18333],0); -ELEMENTS[71069] = Fluid3D([13974,13546,13921,13844],0); -ELEMENTS[71070] = Fluid3D([3847,4147,4207,4591],0); -ELEMENTS[71071] = Fluid3D([17562,17491,17171,17347],0); -ELEMENTS[71072] = Fluid3D([15858,15550,15033,15757],0); -ELEMENTS[71073] = Fluid3D([18546,18415,18426,18580],0); -ELEMENTS[71074] = Fluid3D([11363,11162,12209,12327],0); -ELEMENTS[71075] = Fluid3D([7860,8694,9095,8915],0); -ELEMENTS[71076] = Fluid3D([8694,9095,8915,9321],0); -ELEMENTS[71077] = Fluid3D([1985,2019,2197,2250],0); -ELEMENTS[71078] = Fluid3D([3630,3795,3877,3970],0); -ELEMENTS[71079] = Fluid3D([3046,3490,3489,3402],0); -ELEMENTS[71080] = Fluid3D([3490,3489,3402,3814],0); -ELEMENTS[71081] = Fluid3D([3489,3046,3402,3186],0); -ELEMENTS[71082] = Fluid3D([3402,3489,3186,3618],0); -ELEMENTS[71083] = Fluid3D([3489,3186,3618,2889],0); -ELEMENTS[71084] = Fluid3D([3046,3402,3186,3025],0); -ELEMENTS[71085] = Fluid3D([3402,3186,3025,3410],0); -ELEMENTS[71086] = Fluid3D([3402,3489,3618,3814],0); -ELEMENTS[71087] = Fluid3D([3186,3046,3025,2889],0); -ELEMENTS[71088] = Fluid3D([3025,3186,2889,3213],0); -ELEMENTS[71089] = Fluid3D([3025,3186,3213,3394],0); -ELEMENTS[71090] = Fluid3D([3025,3186,3394,3410],0); -ELEMENTS[71091] = Fluid3D([3186,3213,3394,3618],0); -ELEMENTS[71092] = Fluid3D([3394,3186,3618,3402],0); -ELEMENTS[71093] = Fluid3D([3213,3025,3394,3367],0); -ELEMENTS[71094] = Fluid3D([3186,2889,3213,3618],0); -ELEMENTS[71095] = Fluid3D([3394,3186,3402,3410],0); -ELEMENTS[71096] = Fluid3D([3213,3394,3618,3367],0); -ELEMENTS[71097] = Fluid3D([3213,3025,3367,2936],0); -ELEMENTS[71098] = Fluid3D([3367,3213,2936,3204],0); -ELEMENTS[71099] = Fluid3D([3213,3025,2936,2889],0); -ELEMENTS[71100] = Fluid3D([2936,3213,2889,3401],0); -ELEMENTS[71101] = Fluid3D([2936,3213,3401,3383],0); -ELEMENTS[71102] = Fluid3D([3394,3025,3410,3575],0); -ELEMENTS[71103] = Fluid3D([3410,3394,3575,3618],0); -ELEMENTS[71104] = Fluid3D([3394,3575,3618,3367],0); -ELEMENTS[71105] = Fluid3D([3410,3394,3618,3402],0); -ELEMENTS[71106] = Fluid3D([3186,3046,2889,3489],0); -ELEMENTS[71107] = Fluid3D([3394,3575,3367,3025],0); -ELEMENTS[71108] = Fluid3D([3618,3213,3367,3401],0); -ELEMENTS[71109] = Fluid3D([3213,3367,3401,3383],0); -ELEMENTS[71110] = Fluid3D([3618,3213,3401,2889],0); -ELEMENTS[71111] = Fluid3D([17510,17816,17591,17666],0); -ELEMENTS[71112] = Fluid3D([2087,2060,2080,1931],0); -ELEMENTS[71113] = Fluid3D([8461,9686,8659,9309],0); -ELEMENTS[71114] = Fluid3D([8790,8348,8634,9678],0); -ELEMENTS[71115] = Fluid3D([1801,1746,1878,1803],0); -ELEMENTS[71116] = Fluid3D([1878,1801,1803,1938],0); -ELEMENTS[71117] = Fluid3D([1801,1803,1938,1722],0); -ELEMENTS[71118] = Fluid3D([1801,1803,1722,1618],0); -ELEMENTS[71119] = Fluid3D([1801,1746,1803,1618],0); -ELEMENTS[71120] = Fluid3D([1803,1878,1938,1932],0); -ELEMENTS[71121] = Fluid3D([1938,1803,1932,1722],0); -ELEMENTS[71122] = Fluid3D([8125,8105,7314,8156],0); -ELEMENTS[71123] = Fluid3D([10287,11087,10344,10677],0); -ELEMENTS[71124] = Fluid3D([11087,10344,10677,11373],0); -ELEMENTS[71125] = Fluid3D([10677,11087,11373,10287],0); -ELEMENTS[71126] = Fluid3D([10344,10287,10677,9966],0); -ELEMENTS[71127] = Fluid3D([10344,10677,11373,10430],0); -ELEMENTS[71128] = Fluid3D([11373,10677,10287,10813],0); -ELEMENTS[71129] = Fluid3D([11373,10677,10813,10430],0); -ELEMENTS[71130] = Fluid3D([10677,10287,10813,9966],0); -ELEMENTS[71131] = Fluid3D([10813,10677,9966,10430],0); -ELEMENTS[71132] = Fluid3D([8102,7272,7326,7443],0); -ELEMENTS[71133] = Fluid3D([15748,15471,14825,15319],0); -ELEMENTS[71134] = Fluid3D([14825,15748,15319,15314],0); -ELEMENTS[71135] = Fluid3D([13158,13470,13683,12805],0); -ELEMENTS[71136] = Fluid3D([16904,16589,17133,17055],0); -ELEMENTS[71137] = Fluid3D([17412,17761,17837,17450],0); -ELEMENTS[71138] = Fluid3D([16909,16818,17108,17402],0); -ELEMENTS[71139] = Fluid3D([16909,16818,17402,17235],0); -ELEMENTS[71140] = Fluid3D([5086,5452,5469,5926],0); -ELEMENTS[71141] = Fluid3D([5795,6342,6442,5916],0); -ELEMENTS[71142] = Fluid3D([6342,6442,5916,6321],0); -ELEMENTS[71143] = Fluid3D([5772,5356,5605,5775],0); -ELEMENTS[71144] = Fluid3D([3065,3098,3458,3669],0); -ELEMENTS[71145] = Fluid3D([3236,3164,3180,2863],0); -ELEMENTS[71146] = Fluid3D([3180,3236,2863,2816],0); -ELEMENTS[71147] = Fluid3D([3236,3164,2863,2692],0); -ELEMENTS[71148] = Fluid3D([4861,5338,4800,5158],0); -ELEMENTS[71149] = Fluid3D([12984,12212,12302,13092],0); -ELEMENTS[71150] = Fluid3D([17921,17708,18043,17846],0); -ELEMENTS[71151] = Fluid3D([3768,4343,4025,4337],0); -ELEMENTS[71152] = Fluid3D([7393,7307,7820,6611],0); -ELEMENTS[71153] = Fluid3D([6910,6262,6690,6645],0); -ELEMENTS[71154] = Fluid3D([8289,7648,8650,9117],0); -ELEMENTS[71155] = Fluid3D([5613,5313,5804,4963],0); -ELEMENTS[71156] = Fluid3D([12302,12128,13271,12813],0); -ELEMENTS[71157] = Fluid3D([7034,7401,6997,6320],0); -ELEMENTS[71158] = Fluid3D([11948,12253,11601,10874],0); -ELEMENTS[71159] = Fluid3D([7818,7844,6946,7634],0); -ELEMENTS[71160] = Fluid3D([3866,4129,4542,4521],0); -ELEMENTS[71161] = Fluid3D([14436,14208,14937,15051],0); -ELEMENTS[71162] = Fluid3D([13049,12490,12949,13279],0); -ELEMENTS[71163] = Fluid3D([18523,18570,18504,18354],0); -ELEMENTS[71164] = Fluid3D([10615,9620,10855,10755],0); -ELEMENTS[71165] = Fluid3D([16929,17281,17228,16661],0); -ELEMENTS[71166] = Fluid3D([13975,14103,13720,13161],0); -ELEMENTS[71167] = Fluid3D([12657,13102,13790,13614],0); -ELEMENTS[71168] = Fluid3D([10898,11133,12010,11442],0); -ELEMENTS[71169] = Fluid3D([13097,13719,13369,13661],0); -ELEMENTS[71170] = Fluid3D([7211,6887,6238,6187],0); -ELEMENTS[71171] = Fluid3D([5874,5656,6228,5432],0); -ELEMENTS[71172] = Fluid3D([17019,17444,17066,17335],0); -ELEMENTS[71173] = Fluid3D([12181,12625,13097,12036],0); -ELEMENTS[71174] = Fluid3D([17025,17229,17286,17621],0); -ELEMENTS[71175] = Fluid3D([16804,17129,16981,16606],0); -ELEMENTS[71176] = Fluid3D([9957,9459,9785,9973],0); -ELEMENTS[71177] = Fluid3D([12262,11786,11314,10873],0); -ELEMENTS[71178] = Fluid3D([16539,16177,16684,16766],0); -ELEMENTS[71179] = Fluid3D([8194,8621,7461,8165],0); -ELEMENTS[71180] = Fluid3D([8194,8621,8165,9546],0); -ELEMENTS[71181] = Fluid3D([8194,8621,9546,9102],0); -ELEMENTS[71182] = Fluid3D([17417,17431,17813,17884],0); -ELEMENTS[71183] = Fluid3D([4463,4330,4508,4053],0); -ELEMENTS[71184] = Fluid3D([15397,15534,15235,15620],0); -ELEMENTS[71185] = Fluid3D([12794,13149,11952,12652],0); -ELEMENTS[71186] = Fluid3D([14365,14329,15029,15469],0); -ELEMENTS[71187] = Fluid3D([12759,12345,11802,11864],0); -ELEMENTS[71188] = Fluid3D([2688,2928,3148,2978],0); -ELEMENTS[71189] = Fluid3D([13629,12705,13505,12847],0); -ELEMENTS[71190] = Fluid3D([15897,15596,16038,15127],0); -ELEMENTS[71191] = Fluid3D([8496,8070,9231,9153],0); -ELEMENTS[71192] = Fluid3D([7147,7653,7586,6918],0); -ELEMENTS[71193] = Fluid3D([13256,12455,12884,12706],0); -ELEMENTS[71194] = Fluid3D([8458,7817,7706,7820],0); -ELEMENTS[71195] = Fluid3D([15891,16049,16261,15804],0); -ELEMENTS[71196] = Fluid3D([13067,13710,12748,13330],0); -ELEMENTS[71197] = Fluid3D([10829,10404,10566,9636],0); -ELEMENTS[71198] = Fluid3D([17218,17453,17039,17487],0); -ELEMENTS[71199] = Fluid3D([5513,5195,4832,5685],0); -ELEMENTS[71200] = Fluid3D([14500,13717,14086,14486],0); -ELEMENTS[71201] = Fluid3D([2494,2229,2215,2300],0); -ELEMENTS[71202] = Fluid3D([18496,18433,18579,18503],0); -ELEMENTS[71203] = Fluid3D([6044,6283,6587,6087],0); -ELEMENTS[71204] = Fluid3D([9455,9687,8834,8771],0); -ELEMENTS[71205] = Fluid3D([3109,3296,3072,3269],0); -ELEMENTS[71206] = Fluid3D([12598,12445,12005,11719],0); -ELEMENTS[71207] = Fluid3D([12445,12005,11719,11298],0); -ELEMENTS[71208] = Fluid3D([12445,12005,11298,11795],0); -ELEMENTS[71209] = Fluid3D([2864,2741,2460,2778],0); -ELEMENTS[71210] = Fluid3D([17010,17131,17276,16593],0); -ELEMENTS[71211] = Fluid3D([11088,10743,11715,10373],0); -ELEMENTS[71212] = Fluid3D([11797,11450,11671,10543],0); -ELEMENTS[71213] = Fluid3D([12254,11657,11009,11603],0); -ELEMENTS[71214] = Fluid3D([12254,11657,11603,11921],0); -ELEMENTS[71215] = Fluid3D([15426,15939,15284,15801],0); -ELEMENTS[71216] = Fluid3D([7146,7274,6591,6255],0); -ELEMENTS[71217] = Fluid3D([6671,7302,6725,6853],0); -ELEMENTS[71218] = Fluid3D([4162,3714,4248,3980],0); -ELEMENTS[71219] = Fluid3D([12200,11890,12823,12165],0); -ELEMENTS[71220] = Fluid3D([12823,12200,12165,13486],0); -ELEMENTS[71221] = Fluid3D([9351,8743,8665,9452],0); -ELEMENTS[71222] = Fluid3D([8665,9351,9452,9860],0); -ELEMENTS[71223] = Fluid3D([8743,8665,9452,8647],0); -ELEMENTS[71224] = Fluid3D([8665,9452,8647,9102],0); -ELEMENTS[71225] = Fluid3D([16190,15690,15405,15838],0); -ELEMENTS[71226] = Fluid3D([14905,14254,14310,13997],0); -ELEMENTS[71227] = Fluid3D([7606,7725,6750,7308],0); -ELEMENTS[71228] = Fluid3D([7606,7725,7308,7954],0); -ELEMENTS[71229] = Fluid3D([7308,7606,7954,8446],0); -ELEMENTS[71230] = Fluid3D([7606,7725,7954,8446],0); -ELEMENTS[71231] = Fluid3D([16332,15742,16463,16075],0); -ELEMENTS[71232] = Fluid3D([15742,16463,16075,16228],0); -ELEMENTS[71233] = Fluid3D([18443,18289,18306,18117],0); -ELEMENTS[71234] = Fluid3D([15556,16292,15963,16249],0); -ELEMENTS[71235] = Fluid3D([11739,12292,11363,11825],0); -ELEMENTS[71236] = Fluid3D([13892,13686,13399,12917],0); -ELEMENTS[71237] = Fluid3D([6370,6132,6491,6937],0); -ELEMENTS[71238] = Fluid3D([7154,7828,8021,7554],0); -ELEMENTS[71239] = Fluid3D([17841,17876,17650,18097],0); -ELEMENTS[71240] = Fluid3D([8226,7784,8066,9179],0); -ELEMENTS[71241] = Fluid3D([15297,16010,15565,15816],0); -ELEMENTS[71242] = Fluid3D([17003,16859,17204,17305],0); -ELEMENTS[71243] = Fluid3D([10780,11315,11293,11904],0); -ELEMENTS[71244] = Fluid3D([10780,11315,11904,11839],0); -ELEMENTS[71245] = Fluid3D([11315,11904,11839,12157],0); -ELEMENTS[71246] = Fluid3D([11315,11293,11904,11014],0); -ELEMENTS[71247] = Fluid3D([11904,11315,11014,12181],0); -ELEMENTS[71248] = Fluid3D([11315,11904,12157,12181],0); -ELEMENTS[71249] = Fluid3D([8999,8372,8692,8585],0); -ELEMENTS[71250] = Fluid3D([3647,3480,3335,3135],0); -ELEMENTS[71251] = Fluid3D([3480,3335,3135,3038],0); -ELEMENTS[71252] = Fluid3D([3335,3135,3038,2851],0); -ELEMENTS[71253] = Fluid3D([10206,9899,11082,10706],0); -ELEMENTS[71254] = Fluid3D([15745,15966,15417,16239],0); -ELEMENTS[71255] = Fluid3D([5416,5392,5413,5108],0); -ELEMENTS[71256] = Fluid3D([8653,9444,9084,8452],0); -ELEMENTS[71257] = Fluid3D([5016,5701,5458,5686],0); -ELEMENTS[71258] = Fluid3D([12935,11908,12391,12953],0); -ELEMENTS[71259] = Fluid3D([12391,12935,12953,13680],0); -ELEMENTS[71260] = Fluid3D([4996,4568,4525,4583],0); -ELEMENTS[71261] = Fluid3D([9357,8282,9067,9516],0); -ELEMENTS[71262] = Fluid3D([4047,4058,3822,3540],0); -ELEMENTS[71263] = Fluid3D([4226,4240,3741,4523],0); -ELEMENTS[71264] = Fluid3D([4226,4240,4523,4537],0); -ELEMENTS[71265] = Fluid3D([12929,12806,12610,11821],0); -ELEMENTS[71266] = Fluid3D([18393,18495,18570,18354],0); -ELEMENTS[71267] = Fluid3D([18393,18495,18354,18305],0); -ELEMENTS[71268] = Fluid3D([2163,1960,2141,2198],0); -ELEMENTS[71269] = Fluid3D([15270,14767,15071,15309],0); -ELEMENTS[71270] = Fluid3D([2567,2402,2714,2751],0); -ELEMENTS[71271] = Fluid3D([3566,3878,3520,3743],0); -ELEMENTS[71272] = Fluid3D([3665,3540,4047,3822],0); -ELEMENTS[71273] = Fluid3D([12297,12048,12280,11884],0); -ELEMENTS[71274] = Fluid3D([12297,12048,11884,11184],0); -ELEMENTS[71275] = Fluid3D([12280,12297,11884,13017],0); -ELEMENTS[71276] = Fluid3D([12555,12260,13075,13575],0); -ELEMENTS[71277] = Fluid3D([5886,5538,4953,5452],0); -ELEMENTS[71278] = Fluid3D([5886,5538,5452,5801],0); -ELEMENTS[71279] = Fluid3D([8573,8849,8065,8634],0); -ELEMENTS[71280] = Fluid3D([8573,8849,8634,9902],0); -ELEMENTS[71281] = Fluid3D([13297,12739,13711,13807],0); -ELEMENTS[71282] = Fluid3D([2098,2007,1875,2056],0); -ELEMENTS[71283] = Fluid3D([8804,8599,9433,8917],0); -ELEMENTS[71284] = Fluid3D([16661,16929,16669,17228],0); -ELEMENTS[71285] = Fluid3D([16627,16660,17158,17016],0); -ELEMENTS[71286] = Fluid3D([15523,15719,15390,16092],0); -ELEMENTS[71287] = Fluid3D([6438,7512,7416,6861],0); -ELEMENTS[71288] = Fluid3D([1878,1811,1915,1932],0); -ELEMENTS[71289] = Fluid3D([1811,1915,1932,2009],0); -ELEMENTS[71290] = Fluid3D([2978,2727,2948,3290],0); -ELEMENTS[71291] = Fluid3D([7693,6803,6959,7869],0); -ELEMENTS[71292] = Fluid3D([15428,14987,15686,15957],0); -ELEMENTS[71293] = Fluid3D([18332,18333,18132,18252],0); -ELEMENTS[71294] = Fluid3D([9452,8665,9860,9102],0); -ELEMENTS[71295] = Fluid3D([13867,13455,13372,12568],0); -ELEMENTS[71296] = Fluid3D([12512,11535,12691,11646],0); -ELEMENTS[71297] = Fluid3D([7926,7353,7829,8006],0); -ELEMENTS[71298] = Fluid3D([9688,9809,8819,9850],0); -ELEMENTS[71299] = Fluid3D([5964,5896,5288,5232],0); -ELEMENTS[71300] = Fluid3D([9576,9929,10870,9971],0); -ELEMENTS[71301] = Fluid3D([9686,8659,9309,9884],0); -ELEMENTS[71302] = Fluid3D([17936,18208,18264,17958],0); -ELEMENTS[71303] = Fluid3D([11975,12427,11615,12419],0); -ELEMENTS[71304] = Fluid3D([9374,8550,9174,9688],0); -ELEMENTS[71305] = Fluid3D([3169,3497,3336,3473],0); -ELEMENTS[71306] = Fluid3D([6029,6573,5856,5920],0); -ELEMENTS[71307] = Fluid3D([16471,16253,16699,16915],0); -ELEMENTS[71308] = Fluid3D([9502,9551,10774,10359],0); -ELEMENTS[71309] = Fluid3D([13012,13796,12823,12764],0); -ELEMENTS[71310] = Fluid3D([7969,7277,7036,6512],0); -ELEMENTS[71311] = Fluid3D([12358,12986,11692,12382],0); -ELEMENTS[71312] = Fluid3D([3470,3277,3563,3726],0); -ELEMENTS[71313] = Fluid3D([3470,3277,3726,3621],0); -ELEMENTS[71314] = Fluid3D([3563,3470,3726,3838],0); -ELEMENTS[71315] = Fluid3D([3470,3726,3838,3938],0); -ELEMENTS[71316] = Fluid3D([12053,11790,12797,12530],0); -ELEMENTS[71317] = Fluid3D([5483,5452,4953,4710],0); -ELEMENTS[71318] = Fluid3D([5060,4743,4691,4506],0); -ELEMENTS[71319] = Fluid3D([11701,10503,11163,11331],0); -ELEMENTS[71320] = Fluid3D([10503,11163,11331,10498],0); -ELEMENTS[71321] = Fluid3D([5685,5535,6005,5195],0); -ELEMENTS[71322] = Fluid3D([17030,17005,16877,16828],0); -ELEMENTS[71323] = Fluid3D([12414,12934,12047,12246],0); -ELEMENTS[71324] = Fluid3D([18680,18690,18650,18681],0); -ELEMENTS[71325] = Fluid3D([12524,13122,12817,13489],0); -ELEMENTS[71326] = Fluid3D([7555,6755,6985,7785],0); -ELEMENTS[71327] = Fluid3D([6278,6898,7135,5995],0); -ELEMENTS[71328] = Fluid3D([3219,2878,3205,3433],0); -ELEMENTS[71329] = Fluid3D([8333,8816,8350,8612],0); -ELEMENTS[71330] = Fluid3D([14597,14348,14226,14437],0); -ELEMENTS[71331] = Fluid3D([14622,13681,13806,14001],0); -ELEMENTS[71332] = Fluid3D([13681,13806,14001,13435],0); -ELEMENTS[71333] = Fluid3D([14001,13681,13435,14258],0); -ELEMENTS[71334] = Fluid3D([13435,14001,14258,14645],0); -ELEMENTS[71335] = Fluid3D([14001,14258,14645,14791],0); -ELEMENTS[71336] = Fluid3D([14645,14001,14791,13811],0); -ELEMENTS[71337] = Fluid3D([14001,14258,14791,14622],0); -ELEMENTS[71338] = Fluid3D([14791,14001,14622,13806],0); -ELEMENTS[71339] = Fluid3D([14622,13681,14001,14258],0); -ELEMENTS[71340] = Fluid3D([14645,14001,13811,13435],0); -ELEMENTS[71341] = Fluid3D([14001,13811,13435,13119],0); -ELEMENTS[71342] = Fluid3D([13435,14001,13119,13806],0); -ELEMENTS[71343] = Fluid3D([14791,14645,13811,14400],0); -ELEMENTS[71344] = Fluid3D([14791,14001,13806,13811],0); -ELEMENTS[71345] = Fluid3D([14001,13806,13811,13119],0); -ELEMENTS[71346] = Fluid3D([8137,8376,7537,8651],0); -ELEMENTS[71347] = Fluid3D([16381,16132,16453,16939],0); -ELEMENTS[71348] = Fluid3D([18047,18055,17773,17993],0); -ELEMENTS[71349] = Fluid3D([6688,7600,6941,7721],0); -ELEMENTS[71350] = Fluid3D([7600,6941,7721,7601],0); -ELEMENTS[71351] = Fluid3D([7721,7600,7601,8231],0); -ELEMENTS[71352] = Fluid3D([7601,7721,8231,7584],0); -ELEMENTS[71353] = Fluid3D([8231,7601,7584,7260],0); -ELEMENTS[71354] = Fluid3D([8231,7601,7260,7600],0); -ELEMENTS[71355] = Fluid3D([7601,7584,7260,6538],0); -ELEMENTS[71356] = Fluid3D([7601,7260,7600,6941],0); -ELEMENTS[71357] = Fluid3D([6941,7721,7601,7584],0); -ELEMENTS[71358] = Fluid3D([7260,7601,6538,6941],0); -ELEMENTS[71359] = Fluid3D([7601,6538,6941,7584],0); -ELEMENTS[71360] = Fluid3D([3894,3401,3489,3618],0); -ELEMENTS[71361] = Fluid3D([3401,3489,3618,2889],0); -ELEMENTS[71362] = Fluid3D([7202,6722,7785,7927],0); -ELEMENTS[71363] = Fluid3D([18243,18246,18428,18468],0); -ELEMENTS[71364] = Fluid3D([17085,17364,17210,16873],0); -ELEMENTS[71365] = Fluid3D([15009,15785,15079,15256],0); -ELEMENTS[71366] = Fluid3D([12907,12525,13146,13794],0); -ELEMENTS[71367] = Fluid3D([2642,2936,2659,2973],0); -ELEMENTS[71368] = Fluid3D([5978,5719,6393,5675],0); -ELEMENTS[71369] = Fluid3D([2212,2314,2403,2237],0); -ELEMENTS[71370] = Fluid3D([5303,5847,5778,5995],0); -ELEMENTS[71371] = Fluid3D([2061,1938,1931,1878],0); -ELEMENTS[71372] = Fluid3D([6479,6184,6185,7025],0); -ELEMENTS[71373] = Fluid3D([5135,4571,4804,5065],0); -ELEMENTS[71374] = Fluid3D([2143,2081,2337,2135],0); -ELEMENTS[71375] = Fluid3D([2124,2288,2320,2263],0); -ELEMENTS[71376] = Fluid3D([4986,4774,4583,4241],0); -ELEMENTS[71377] = Fluid3D([8599,8054,7968,7402],0); -ELEMENTS[71378] = Fluid3D([7757,7761,6911,7461],0); -ELEMENTS[71379] = Fluid3D([15853,15943,15370,15487],0); -ELEMENTS[71380] = Fluid3D([14552,13926,13932,13992],0); -ELEMENTS[71381] = Fluid3D([2466,2253,2374,2273],0); -ELEMENTS[71382] = Fluid3D([8149,8520,8046,7425],0); -ELEMENTS[71383] = Fluid3D([5742,6476,6495,6005],0); -ELEMENTS[71384] = Fluid3D([5297,4784,4565,5040],0); -ELEMENTS[71385] = Fluid3D([5297,4784,5040,4912],0); -ELEMENTS[71386] = Fluid3D([17289,17261,17297,17560],0); -ELEMENTS[71387] = Fluid3D([14071,14517,14250,13803],0); -ELEMENTS[71388] = Fluid3D([14250,14071,13803,13023],0); -ELEMENTS[71389] = Fluid3D([13803,14250,13023,13648],0); -ELEMENTS[71390] = Fluid3D([13023,13803,13648,13805],0); -ELEMENTS[71391] = Fluid3D([13803,13648,13805,14517],0); -ELEMENTS[71392] = Fluid3D([13805,13803,14517,14071],0); -ELEMENTS[71393] = Fluid3D([13805,13803,14071,13277],0); -ELEMENTS[71394] = Fluid3D([13023,13803,13805,13277],0); -ELEMENTS[71395] = Fluid3D([14517,14250,13803,13648],0); -ELEMENTS[71396] = Fluid3D([14071,13803,13023,13173],0); -ELEMENTS[71397] = Fluid3D([13803,13023,13173,13277],0); -ELEMENTS[71398] = Fluid3D([14071,13803,13173,13277],0); -ELEMENTS[71399] = Fluid3D([16889,16836,17136,17168],0); -ELEMENTS[71400] = Fluid3D([12652,13218,13801,14284],0); -ELEMENTS[71401] = Fluid3D([4344,4189,3950,3737],0); -ELEMENTS[71402] = Fluid3D([5390,5008,4845,5316],0); -ELEMENTS[71403] = Fluid3D([16068,16312,16444,16874],0); -ELEMENTS[71404] = Fluid3D([13924,14496,14871,13687],0); -ELEMENTS[71405] = Fluid3D([6189,6008,5270,5478],0); -ELEMENTS[71406] = Fluid3D([4911,4634,4476,4327],0); -ELEMENTS[71407] = Fluid3D([4911,4634,4327,4756],0); -ELEMENTS[71408] = Fluid3D([7883,8492,8795,8840],0); -ELEMENTS[71409] = Fluid3D([17918,17756,17550,17547],0); -ELEMENTS[71410] = Fluid3D([17495,17710,17834,17378],0); -ELEMENTS[71411] = Fluid3D([18679,18688,18659,18687],0); -ELEMENTS[71412] = Fluid3D([4133,4555,4027,4279],0); -ELEMENTS[71413] = Fluid3D([8582,9271,9437,10074],0); -ELEMENTS[71414] = Fluid3D([7855,8903,8297,8969],0); -ELEMENTS[71415] = Fluid3D([8297,7855,8969,7661],0); -ELEMENTS[71416] = Fluid3D([8903,8297,8969,9402],0); -ELEMENTS[71417] = Fluid3D([17102,17356,17665,17642],0); -ELEMENTS[71418] = Fluid3D([16673,16427,16813,17115],0); -ELEMENTS[71419] = Fluid3D([14798,14379,15380,15175],0); -ELEMENTS[71420] = Fluid3D([10272,10240,10570,9973],0); -ELEMENTS[71421] = Fluid3D([9601,10221,9712,9120],0); -ELEMENTS[71422] = Fluid3D([10422,9828,9225,9421],0); -ELEMENTS[71423] = Fluid3D([17556,17508,17654,17144],0); -ELEMENTS[71424] = Fluid3D([12440,12568,12856,13213],0); -ELEMENTS[71425] = Fluid3D([2518,2346,2211,2254],0); -ELEMENTS[71426] = Fluid3D([16886,16834,16434,16246],0); -ELEMENTS[71427] = Fluid3D([15977,16327,16280,16024],0); -ELEMENTS[71428] = Fluid3D([16280,15977,16024,15541],0); -ELEMENTS[71429] = Fluid3D([17652,17756,17514,17770],0); -ELEMENTS[71430] = Fluid3D([11260,11612,11086,11962],0); -ELEMENTS[71431] = Fluid3D([7428,8403,7587,7561],0); -ELEMENTS[71432] = Fluid3D([3032,3374,3402,3410],0); -ELEMENTS[71433] = Fluid3D([2724,2626,2749,3064],0); -ELEMENTS[71434] = Fluid3D([14513,14460,13754,14858],0); -ELEMENTS[71435] = Fluid3D([4350,3945,4572,4125],0); -ELEMENTS[71436] = Fluid3D([10681,10525,11134,11613],0); -ELEMENTS[71437] = Fluid3D([8049,8194,8165,8852],0); -ELEMENTS[71438] = Fluid3D([13926,14456,13992,14552],0); -ELEMENTS[71439] = Fluid3D([13926,14456,14552,15133],0); -ELEMENTS[71440] = Fluid3D([11243,10606,11571,11783],0); -ELEMENTS[71441] = Fluid3D([4638,5276,4832,4753],0); -ELEMENTS[71442] = Fluid3D([7925,7180,7629,8217],0); -ELEMENTS[71443] = Fluid3D([8657,9393,9165,8153],0); -ELEMENTS[71444] = Fluid3D([1976,1829,1809,1873],0); -ELEMENTS[71445] = Fluid3D([16611,16515,16955,17197],0); -ELEMENTS[71446] = Fluid3D([3247,2957,3024,2777],0); -ELEMENTS[71447] = Fluid3D([13572,14119,14298,13768],0); -ELEMENTS[71448] = Fluid3D([14298,13572,13768,13471],0); -ELEMENTS[71449] = Fluid3D([4891,5032,5560,4887],0); -ELEMENTS[71450] = Fluid3D([9695,9934,10754,9886],0); -ELEMENTS[71451] = Fluid3D([9695,9934,9886,8751],0); -ELEMENTS[71452] = Fluid3D([4897,4871,4442,5334],0); -ELEMENTS[71453] = Fluid3D([7453,8293,7191,7269],0); -ELEMENTS[71454] = Fluid3D([13884,13243,13959,14452],0); -ELEMENTS[71455] = Fluid3D([5025,5028,5608,4974],0); -ELEMENTS[71456] = Fluid3D([5025,5028,4974,4377],0); -ELEMENTS[71457] = Fluid3D([5608,5025,4974,4685],0); -ELEMENTS[71458] = Fluid3D([5025,4974,4685,4377],0); -ELEMENTS[71459] = Fluid3D([4974,5608,4685,5252],0); -ELEMENTS[71460] = Fluid3D([4685,4974,5252,4759],0); -ELEMENTS[71461] = Fluid3D([4685,4974,4759,4377],0); -ELEMENTS[71462] = Fluid3D([4974,5252,4759,5400],0); -ELEMENTS[71463] = Fluid3D([4759,4974,5400,5028],0); -ELEMENTS[71464] = Fluid3D([4974,5252,5400,5608],0); -ELEMENTS[71465] = Fluid3D([5400,4974,5608,5028],0); -ELEMENTS[71466] = Fluid3D([5252,5400,5608,6240],0); -ELEMENTS[71467] = Fluid3D([4759,4974,5028,4377],0); -ELEMENTS[71468] = Fluid3D([12518,11698,12179,11635],0); -ELEMENTS[71469] = Fluid3D([12518,11698,11635,11861],0); -ELEMENTS[71470] = Fluid3D([11698,11635,11861,10637],0); -ELEMENTS[71471] = Fluid3D([11698,11635,10637,11045],0); -ELEMENTS[71472] = Fluid3D([11698,11635,11045,12179],0); -ELEMENTS[71473] = Fluid3D([8489,7722,9391,8693],0); -ELEMENTS[71474] = Fluid3D([8355,9505,9051,8696],0); -ELEMENTS[71475] = Fluid3D([8355,9505,8696,8641],0); -ELEMENTS[71476] = Fluid3D([9051,8355,8696,7831],0); -ELEMENTS[71477] = Fluid3D([8355,8696,7831,8641],0); -ELEMENTS[71478] = Fluid3D([8696,7831,8641,8936],0); -ELEMENTS[71479] = Fluid3D([8641,8696,8936,9505],0); -ELEMENTS[71480] = Fluid3D([9505,9051,8696,9845],0); -ELEMENTS[71481] = Fluid3D([9051,8696,9845,8781],0); -ELEMENTS[71482] = Fluid3D([9051,8696,8781,7831],0); -ELEMENTS[71483] = Fluid3D([8696,9845,8781,8936],0); -ELEMENTS[71484] = Fluid3D([8781,8696,8936,7831],0); -ELEMENTS[71485] = Fluid3D([9505,9051,9845,10540],0); -ELEMENTS[71486] = Fluid3D([8696,9505,9845,8936],0); -ELEMENTS[71487] = Fluid3D([17460,17522,17820,17864],0); -ELEMENTS[71488] = Fluid3D([14127,13606,13882,14833],0); -ELEMENTS[71489] = Fluid3D([18087,18232,17832,18011],0); -ELEMENTS[71490] = Fluid3D([9487,10087,9029,9476],0); -ELEMENTS[71491] = Fluid3D([8545,8671,7542,8462],0); -ELEMENTS[71492] = Fluid3D([5761,5805,5295,5018],0); -ELEMENTS[71493] = Fluid3D([5805,5295,5018,5524],0); -ELEMENTS[71494] = Fluid3D([13157,13652,13308,13633],0); -ELEMENTS[71495] = Fluid3D([13016,12505,11900,12702],0); -ELEMENTS[71496] = Fluid3D([13571,12610,13428,13307],0); -ELEMENTS[71497] = Fluid3D([3277,3588,3314,3552],0); -ELEMENTS[71498] = Fluid3D([3277,3588,3552,3726],0); -ELEMENTS[71499] = Fluid3D([3552,3277,3726,3563],0); -ELEMENTS[71500] = Fluid3D([3588,3552,3726,3591],0); -ELEMENTS[71501] = Fluid3D([3552,3726,3591,3563],0); -ELEMENTS[71502] = Fluid3D([3591,3552,3563,3277],0); -ELEMENTS[71503] = Fluid3D([3591,3552,3277,3314],0); -ELEMENTS[71504] = Fluid3D([3591,3552,3314,3588],0); -ELEMENTS[71505] = Fluid3D([3726,3591,3563,4225],0); -ELEMENTS[71506] = Fluid3D([3726,3591,4225,4172],0); -ELEMENTS[71507] = Fluid3D([4225,3726,4172,3938],0); -ELEMENTS[71508] = Fluid3D([3726,3588,3591,3830],0); -ELEMENTS[71509] = Fluid3D([3726,3588,3830,3621],0); -ELEMENTS[71510] = Fluid3D([3588,3830,3621,3324],0); -ELEMENTS[71511] = Fluid3D([3588,3830,3324,3693],0); -ELEMENTS[71512] = Fluid3D([3588,3830,3693,3314],0); -ELEMENTS[71513] = Fluid3D([3621,3588,3324,3277],0); -ELEMENTS[71514] = Fluid3D([3588,3830,3314,3591],0); -ELEMENTS[71515] = Fluid3D([3621,3588,3277,3726],0); -ELEMENTS[71516] = Fluid3D([3726,3591,4172,3830],0); -ELEMENTS[71517] = Fluid3D([4172,3726,3830,3621],0); -ELEMENTS[71518] = Fluid3D([14530,15374,15205,14495],0); -ELEMENTS[71519] = Fluid3D([8987,9574,10224,10062],0); -ELEMENTS[71520] = Fluid3D([13302,13339,12802,12187],0); -ELEMENTS[71521] = Fluid3D([7032,6258,6376,6606],0); -ELEMENTS[71522] = Fluid3D([17503,17086,17276,17131],0); -ELEMENTS[71523] = Fluid3D([14486,13673,13717,14086],0); -ELEMENTS[71524] = Fluid3D([17216,17068,16871,17309],0); -ELEMENTS[71525] = Fluid3D([18023,17756,17652,17770],0); -ELEMENTS[71526] = Fluid3D([12260,11534,11979,11044],0); -ELEMENTS[71527] = Fluid3D([14954,15293,15625,14546],0); -ELEMENTS[71528] = Fluid3D([7886,8645,7639,8079],0); -ELEMENTS[71529] = Fluid3D([7886,8645,8079,8509],0); -ELEMENTS[71530] = Fluid3D([7639,7886,8079,6993],0); -ELEMENTS[71531] = Fluid3D([5240,5458,5335,5957],0); -ELEMENTS[71532] = Fluid3D([13504,13043,13857,13827],0); -ELEMENTS[71533] = Fluid3D([12498,11531,11985,11556],0); -ELEMENTS[71534] = Fluid3D([3480,3158,3135,3168],0); -ELEMENTS[71535] = Fluid3D([18473,18577,18436,18474],0); -ELEMENTS[71536] = Fluid3D([12993,12988,13661,13462],0); -ELEMENTS[71537] = Fluid3D([11347,10359,11208,11397],0); -ELEMENTS[71538] = Fluid3D([5542,5346,4757,4957],0); -ELEMENTS[71539] = Fluid3D([13501,13819,12679,13441],0); -ELEMENTS[71540] = Fluid3D([12619,12589,12358,11411],0); -ELEMENTS[71541] = Fluid3D([15596,15357,15557,16317],0); -ELEMENTS[71542] = Fluid3D([4899,4905,4385,5038],0); -ELEMENTS[71543] = Fluid3D([10014,9328,9741,10753],0); -ELEMENTS[71544] = Fluid3D([6954,6935,7791,7916],0); -ELEMENTS[71545] = Fluid3D([11417,10888,10319,11023],0); -ELEMENTS[71546] = Fluid3D([4506,5060,5059,4691],0); -ELEMENTS[71547] = Fluid3D([2535,2378,2872,2601],0); -ELEMENTS[71548] = Fluid3D([2535,2378,2601,2453],0); -ELEMENTS[71549] = Fluid3D([2535,2378,2453,2137],0); -ELEMENTS[71550] = Fluid3D([9216,8302,8771,9455],0); -ELEMENTS[71551] = Fluid3D([18654,18653,18617,18571],0); -ELEMENTS[71552] = Fluid3D([10219,9296,10587,10390],0); -ELEMENTS[71553] = Fluid3D([16980,16659,17164,17180],0); -ELEMENTS[71554] = Fluid3D([15879,16312,16588,16262],0); -ELEMENTS[71555] = Fluid3D([15879,16312,16262,16230],0); -ELEMENTS[71556] = Fluid3D([18329,18143,18148,18347],0); -ELEMENTS[71557] = Fluid3D([3631,3548,3623,4205],0); -ELEMENTS[71558] = Fluid3D([11059,11377,10556,11975],0); -ELEMENTS[71559] = Fluid3D([9361,8788,10114,8852],0); -ELEMENTS[71560] = Fluid3D([3011,2753,2660,2931],0); -ELEMENTS[71561] = Fluid3D([4744,5098,4476,5131],0); -ELEMENTS[71562] = Fluid3D([5605,5033,4835,5307],0); -ELEMENTS[71563] = Fluid3D([18334,18185,18393,18483],0); -ELEMENTS[71564] = Fluid3D([17794,17493,17752,17587],0); -ELEMENTS[71565] = Fluid3D([17794,17493,17587,17540],0); -ELEMENTS[71566] = Fluid3D([17794,17493,17540,17543],0); -ELEMENTS[71567] = Fluid3D([17493,17540,17543,17045],0); -ELEMENTS[71568] = Fluid3D([17493,17540,17045,17239],0); -ELEMENTS[71569] = Fluid3D([17493,17540,17239,17587],0); -ELEMENTS[71570] = Fluid3D([17239,17493,17587,17532],0); -ELEMENTS[71571] = Fluid3D([2383,2187,2346,2144],0); -ELEMENTS[71572] = Fluid3D([16344,15898,16628,16186],0); -ELEMENTS[71573] = Fluid3D([7996,7442,8441,7459],0); -ELEMENTS[71574] = Fluid3D([17254,17352,17393,17700],0); -ELEMENTS[71575] = Fluid3D([17352,17393,17700,17634],0); -ELEMENTS[71576] = Fluid3D([11807,11366,11972,12079],0); -ELEMENTS[71577] = Fluid3D([14851,14868,15596,15127],0); -ELEMENTS[71578] = Fluid3D([14851,14868,15127,14255],0); -ELEMENTS[71579] = Fluid3D([15127,14851,14255,14799],0); -ELEMENTS[71580] = Fluid3D([15596,14851,15127,15897],0); -ELEMENTS[71581] = Fluid3D([9998,10185,10786,9420],0); -ELEMENTS[71582] = Fluid3D([9998,10185,9420,8961],0); -ELEMENTS[71583] = Fluid3D([16390,15784,16065,16116],0); -ELEMENTS[71584] = Fluid3D([4888,4393,4773,4886],0); -ELEMENTS[71585] = Fluid3D([5814,6399,6407,7026],0); -ELEMENTS[71586] = Fluid3D([3933,3608,3852,4081],0); -ELEMENTS[71587] = Fluid3D([3608,3852,4081,3570],0); -ELEMENTS[71588] = Fluid3D([5603,5331,5699,5478],0); -ELEMENTS[71589] = Fluid3D([5331,5699,5478,4746],0); -ELEMENTS[71590] = Fluid3D([17842,17982,17530,17802],0); -ELEMENTS[71591] = Fluid3D([14236,13278,13292,14307],0); -ELEMENTS[71592] = Fluid3D([14582,14252,15337,14814],0); -ELEMENTS[71593] = Fluid3D([4756,4467,4840,4193],0); -ELEMENTS[71594] = Fluid3D([4325,3980,4487,4248],0); -ELEMENTS[71595] = Fluid3D([17757,17679,17585,17274],0); -ELEMENTS[71596] = Fluid3D([2427,2250,2620,2547],0); -ELEMENTS[71597] = Fluid3D([15274,15629,14710,15434],0); -ELEMENTS[71598] = Fluid3D([8657,9285,9393,9653],0); -ELEMENTS[71599] = Fluid3D([7333,6765,7285,6442],0); -ELEMENTS[71600] = Fluid3D([9587,9096,8322,9215],0); -ELEMENTS[71601] = Fluid3D([16901,16564,16882,16796],0); -ELEMENTS[71602] = Fluid3D([16901,16564,16796,16164],0); -ELEMENTS[71603] = Fluid3D([10819,11189,9933,10297],0); -ELEMENTS[71604] = Fluid3D([1575,1639,1727,1641],0); -ELEMENTS[71605] = Fluid3D([17198,17361,17681,17496],0); -ELEMENTS[71606] = Fluid3D([17566,17189,17100,17287],0); -ELEMENTS[71607] = Fluid3D([14585,15099,15045,15369],0); -ELEMENTS[71608] = Fluid3D([7253,6443,6180,6406],0); -ELEMENTS[71609] = Fluid3D([10400,9889,9660,10376],0); -ELEMENTS[71610] = Fluid3D([10400,9889,10376,10613],0); -ELEMENTS[71611] = Fluid3D([9889,10376,10613,10337],0); -ELEMENTS[71612] = Fluid3D([9889,9660,10376,9748],0); -ELEMENTS[71613] = Fluid3D([10376,9889,9748,10337],0); -ELEMENTS[71614] = Fluid3D([9889,10400,9715,10613],0); -ELEMENTS[71615] = Fluid3D([9715,9889,10613,10337],0); -ELEMENTS[71616] = Fluid3D([10613,9715,10337,9327],0); -ELEMENTS[71617] = Fluid3D([7556,7618,8692,8250],0); -ELEMENTS[71618] = Fluid3D([17792,17929,17705,18095],0); -ELEMENTS[71619] = Fluid3D([5315,5265,4997,5742],0); -ELEMENTS[71620] = Fluid3D([5315,5265,5742,6112],0); -ELEMENTS[71621] = Fluid3D([16169,16721,16158,16308],0); -ELEMENTS[71622] = Fluid3D([16158,16169,16308,15800],0); -ELEMENTS[71623] = Fluid3D([16308,16158,15800,15702],0); -ELEMENTS[71624] = Fluid3D([16158,16169,15800,15934],0); -ELEMENTS[71625] = Fluid3D([16158,15800,15702,15320],0); -ELEMENTS[71626] = Fluid3D([16158,15800,15320,15934],0); -ELEMENTS[71627] = Fluid3D([9457,10011,10947,9920],0); -ELEMENTS[71628] = Fluid3D([9457,10011,9920,10139],0); -ELEMENTS[71629] = Fluid3D([2771,2627,2433,2697],0); -ELEMENTS[71630] = Fluid3D([15339,15503,15600,16030],0); -ELEMENTS[71631] = Fluid3D([2385,2337,2109,2186],0); -ELEMENTS[71632] = Fluid3D([2385,2337,2186,2438],0); -ELEMENTS[71633] = Fluid3D([15886,15345,15774,15990],0); -ELEMENTS[71634] = Fluid3D([10848,10593,9847,10900],0); -ELEMENTS[71635] = Fluid3D([13121,12607,13708,12507],0); -ELEMENTS[71636] = Fluid3D([16780,16396,16923,16751],0); -ELEMENTS[71637] = Fluid3D([6433,5976,7026,6168],0); -ELEMENTS[71638] = Fluid3D([12149,12917,12981,13399],0); -ELEMENTS[71639] = Fluid3D([12149,12917,13399,12409],0); -ELEMENTS[71640] = Fluid3D([12917,12981,13399,13636],0); -ELEMENTS[71641] = Fluid3D([13399,12917,13636,13892],0); -ELEMENTS[71642] = Fluid3D([12917,12981,13636,12745],0); -ELEMENTS[71643] = Fluid3D([12917,13636,13892,12736],0); -ELEMENTS[71644] = Fluid3D([13636,13399,13892,14265],0); -ELEMENTS[71645] = Fluid3D([13892,13636,14265,13825],0); -ELEMENTS[71646] = Fluid3D([13892,13636,13825,12736],0); -ELEMENTS[71647] = Fluid3D([13636,13399,14265,13860],0); -ELEMENTS[71648] = Fluid3D([14265,13636,13860,13825],0); -ELEMENTS[71649] = Fluid3D([13636,13860,13825,12981],0); -ELEMENTS[71650] = Fluid3D([13636,13860,12981,13399],0); -ELEMENTS[71651] = Fluid3D([13825,13636,12981,12745],0); -ELEMENTS[71652] = Fluid3D([12917,13636,12736,12745],0); -ELEMENTS[71653] = Fluid3D([13825,13636,12745,12736],0); -ELEMENTS[71654] = Fluid3D([16917,16677,16695,16290],0); -ELEMENTS[71655] = Fluid3D([3032,3402,3025,3410],0); -ELEMENTS[71656] = Fluid3D([7118,7374,7904,7837],0); -ELEMENTS[71657] = Fluid3D([14858,14283,13566,13754],0); -ELEMENTS[71658] = Fluid3D([5873,5760,5341,5320],0); -ELEMENTS[71659] = Fluid3D([16238,15986,15651,16240],0); -ELEMENTS[71660] = Fluid3D([1932,2032,1840,1911],0); -ELEMENTS[71661] = Fluid3D([2812,2456,2650,2847],0); -ELEMENTS[71662] = Fluid3D([6625,7217,6265,7154],0); -ELEMENTS[71663] = Fluid3D([16257,15992,15502,16358],0); -ELEMENTS[71664] = Fluid3D([16257,15992,16358,16602],0); -ELEMENTS[71665] = Fluid3D([13219,12934,12246,12047],0); -ELEMENTS[71666] = Fluid3D([11520,10668,10336,10293],0); -ELEMENTS[71667] = Fluid3D([11862,11190,12451,12139],0); -ELEMENTS[71668] = Fluid3D([12451,11862,12139,12798],0); -ELEMENTS[71669] = Fluid3D([14848,15340,14872,14821],0); -ELEMENTS[71670] = Fluid3D([4445,4957,4922,4940],0); -ELEMENTS[71671] = Fluid3D([10424,11217,11768,11964],0); -ELEMENTS[71672] = Fluid3D([13208,13213,13843,13372],0); -ELEMENTS[71673] = Fluid3D([13213,13843,13372,12568],0); -ELEMENTS[71674] = Fluid3D([17261,17645,17643,17560],0); -ELEMENTS[71675] = Fluid3D([8378,8784,7791,7536],0); -ELEMENTS[71676] = Fluid3D([5109,5115,4669,4363],0); -ELEMENTS[71677] = Fluid3D([18682,18652,18690,18673],0); -ELEMENTS[71678] = Fluid3D([10116,9481,10789,10520],0); -ELEMENTS[71679] = Fluid3D([10875,11045,10695,11798],0); -ELEMENTS[71680] = Fluid3D([11845,11358,11492,10838],0); -ELEMENTS[71681] = Fluid3D([17570,17724,17567,17914],0); -ELEMENTS[71682] = Fluid3D([11310,10613,10376,10337],0); -ELEMENTS[71683] = Fluid3D([11310,10613,10337,11492],0); -ELEMENTS[71684] = Fluid3D([13599,13622,13177,14351],0); -ELEMENTS[71685] = Fluid3D([9662,10344,9966,10287],0); -ELEMENTS[71686] = Fluid3D([9662,10344,10287,8866],0); -ELEMENTS[71687] = Fluid3D([18130,17909,17930,17671],0); -ELEMENTS[71688] = Fluid3D([2804,3009,2636,2747],0); -ELEMENTS[71689] = Fluid3D([10357,10275,11445,11168],0); -ELEMENTS[71690] = Fluid3D([3783,3873,3351,3659],0); -ELEMENTS[71691] = Fluid3D([11891,12672,11652,12531],0); -ELEMENTS[71692] = Fluid3D([11594,12212,11300,12097],0); -ELEMENTS[71693] = Fluid3D([13902,13362,13470,14166],0); -ELEMENTS[71694] = Fluid3D([13902,13362,14166,14605],0); -ELEMENTS[71695] = Fluid3D([15298,15367,14892,14700],0); -ELEMENTS[71696] = Fluid3D([15298,15367,14700,15643],0); -ELEMENTS[71697] = Fluid3D([15367,14892,14700,14969],0); -ELEMENTS[71698] = Fluid3D([14700,15367,14969,15643],0); -ELEMENTS[71699] = Fluid3D([12590,13241,12243,13028],0); -ELEMENTS[71700] = Fluid3D([12590,13241,13028,13574],0); -ELEMENTS[71701] = Fluid3D([13241,13028,13574,14196],0); -ELEMENTS[71702] = Fluid3D([18610,18534,18574,18565],0); -ELEMENTS[71703] = Fluid3D([7678,7821,7558,6924],0); -ELEMENTS[71704] = Fluid3D([7678,7821,6924,7471],0); -ELEMENTS[71705] = Fluid3D([7678,7821,7471,7871],0); -ELEMENTS[71706] = Fluid3D([3554,3940,4295,3933],0); -ELEMENTS[71707] = Fluid3D([13378,12903,13650,12682],0); -ELEMENTS[71708] = Fluid3D([11468,10661,10669,11960],0); -ELEMENTS[71709] = Fluid3D([6531,6084,7059,6214],0); -ELEMENTS[71710] = Fluid3D([8437,9384,8752,9040],0); -ELEMENTS[71711] = Fluid3D([18346,18179,18381,18367],0); -ELEMENTS[71712] = Fluid3D([4293,4403,4016,4541],0); -ELEMENTS[71713] = Fluid3D([4293,4403,4541,4946],0); -ELEMENTS[71714] = Fluid3D([4403,4016,4541,3831],0); -ELEMENTS[71715] = Fluid3D([10495,11504,10956,10958],0); -ELEMENTS[71716] = Fluid3D([4615,4948,5153,5043],0); -ELEMENTS[71717] = Fluid3D([4615,4948,5043,4805],0); -ELEMENTS[71718] = Fluid3D([4948,5043,4805,5498],0); -ELEMENTS[71719] = Fluid3D([3070,3335,3038,2851],0); -ELEMENTS[71720] = Fluid3D([12626,12674,11549,12330],0); -ELEMENTS[71721] = Fluid3D([12626,12674,12330,13518],0); -ELEMENTS[71722] = Fluid3D([10470,10651,9917,9285],0); -ELEMENTS[71723] = Fluid3D([16188,16475,16174,15749],0); -ELEMENTS[71724] = Fluid3D([17191,16676,17084,17131],0); -ELEMENTS[71725] = Fluid3D([14092,14713,13877,13563],0); -ELEMENTS[71726] = Fluid3D([11054,10980,11467,10584],0); -ELEMENTS[71727] = Fluid3D([11467,11054,10584,9949],0); -ELEMENTS[71728] = Fluid3D([11054,10980,10584,9728],0); -ELEMENTS[71729] = Fluid3D([11054,10584,9949,9728],0); -ELEMENTS[71730] = Fluid3D([8306,8815,8686,9477],0); -ELEMENTS[71731] = Fluid3D([16004,15642,16145,15703],0); -ELEMENTS[71732] = Fluid3D([13592,13610,14445,13718],0); -ELEMENTS[71733] = Fluid3D([14445,13592,13718,14259],0); -ELEMENTS[71734] = Fluid3D([11450,12190,11729,11030],0); -ELEMENTS[71735] = Fluid3D([16268,16207,16699,16066],0); -ELEMENTS[71736] = Fluid3D([18359,18440,18415,18580],0); -ELEMENTS[71737] = Fluid3D([14738,15051,14937,14208],0); -ELEMENTS[71738] = Fluid3D([6110,6429,5671,6260],0); -ELEMENTS[71739] = Fluid3D([4460,5040,4274,4912],0); -ELEMENTS[71740] = Fluid3D([3704,3497,3913,4159],0); -ELEMENTS[71741] = Fluid3D([8545,8308,8509,9135],0); -ELEMENTS[71742] = Fluid3D([7319,7559,8492,7972],0); -ELEMENTS[71743] = Fluid3D([5146,5457,5998,5469],0); -ELEMENTS[71744] = Fluid3D([5457,5998,5469,5452],0); -ELEMENTS[71745] = Fluid3D([6740,6642,6139,6814],0); -ELEMENTS[71746] = Fluid3D([12967,12575,13417,13918],0); -ELEMENTS[71747] = Fluid3D([15247,14487,15124,14430],0); -ELEMENTS[71748] = Fluid3D([8031,8499,8583,7585],0); -ELEMENTS[71749] = Fluid3D([18574,18493,18588,18620],0); -ELEMENTS[71750] = Fluid3D([4404,3922,4375,3869],0); -ELEMENTS[71751] = Fluid3D([4092,4445,4308,4922],0); -ELEMENTS[71752] = Fluid3D([12943,12085,12496,13161],0); -ELEMENTS[71753] = Fluid3D([18304,18290,18353,18185],0); -ELEMENTS[71754] = Fluid3D([14555,15323,15214,15420],0); -ELEMENTS[71755] = Fluid3D([10536,10943,11827,10927],0); -ELEMENTS[71756] = Fluid3D([2715,2671,2995,3122],0); -ELEMENTS[71757] = Fluid3D([14530,14760,15291,15374],0); -ELEMENTS[71758] = Fluid3D([17908,18085,17915,17715],0); -ELEMENTS[71759] = Fluid3D([16732,16966,16948,16389],0); -ELEMENTS[71760] = Fluid3D([7022,6387,6296,6746],0); -ELEMENTS[71761] = Fluid3D([7022,6387,6746,6987],0); -ELEMENTS[71762] = Fluid3D([6387,6746,6987,6202],0); -ELEMENTS[71763] = Fluid3D([6387,6746,6202,5783],0); -ELEMENTS[71764] = Fluid3D([6202,6387,5783,6987],0); -ELEMENTS[71765] = Fluid3D([6746,6987,6202,6316],0); -ELEMENTS[71766] = Fluid3D([6987,6202,6316,5783],0); -ELEMENTS[71767] = Fluid3D([6202,6316,5783,6191],0); -ELEMENTS[71768] = Fluid3D([6202,6316,6191,6746],0); -ELEMENTS[71769] = Fluid3D([5783,6202,6191,6746],0); -ELEMENTS[71770] = Fluid3D([5875,6187,5347,5806],0); -ELEMENTS[71771] = Fluid3D([8204,9128,8515,9220],0); -ELEMENTS[71772] = Fluid3D([11890,12205,12236,11708],0); -ELEMENTS[71773] = Fluid3D([4800,4669,5158,5461],0); -ELEMENTS[71774] = Fluid3D([10494,9506,9832,9377],0); -ELEMENTS[71775] = Fluid3D([9506,9832,9377,9179],0); -ELEMENTS[71776] = Fluid3D([9832,9377,9179,9652],0); -ELEMENTS[71777] = Fluid3D([11323,11763,10345,10893],0); -ELEMENTS[71778] = Fluid3D([8848,9377,9710,9780],0); -ELEMENTS[71779] = Fluid3D([13773,12944,12767,13766],0); -ELEMENTS[71780] = Fluid3D([13773,12944,13766,13959],0); -ELEMENTS[71781] = Fluid3D([17100,17189,17069,17287],0); -ELEMENTS[71782] = Fluid3D([11963,11149,11604,11429],0); -ELEMENTS[71783] = Fluid3D([11975,11615,11666,12419],0); -ELEMENTS[71784] = Fluid3D([10533,9599,9489,9612],0); -ELEMENTS[71785] = Fluid3D([18378,18412,18297,18452],0); -ELEMENTS[71786] = Fluid3D([15244,14973,15175,14321],0); -ELEMENTS[71787] = Fluid3D([6558,6165,5869,6414],0); -ELEMENTS[71788] = Fluid3D([11703,11189,11935,11945],0); -ELEMENTS[71789] = Fluid3D([7167,7300,6747,7634],0); -ELEMENTS[71790] = Fluid3D([3321,3525,3383,4016],0); -ELEMENTS[71791] = Fluid3D([2394,2174,2464,2398],0); -ELEMENTS[71792] = Fluid3D([9236,9120,10221,9601],0); -ELEMENTS[71793] = Fluid3D([5527,5727,5957,5335],0); -ELEMENTS[71794] = Fluid3D([8182,8276,7309,7811],0); -ELEMENTS[71795] = Fluid3D([8208,7937,7077,7616],0); -ELEMENTS[71796] = Fluid3D([11365,11390,11405,10270],0); -ELEMENTS[71797] = Fluid3D([13440,13768,13310,12432],0); -ELEMENTS[71798] = Fluid3D([14119,14565,14298,13768],0); -ELEMENTS[71799] = Fluid3D([4953,5287,5677,5107],0); -ELEMENTS[71800] = Fluid3D([5287,5677,5107,5657],0); -ELEMENTS[71801] = Fluid3D([4190,4473,4023,4469],0); -ELEMENTS[71802] = Fluid3D([2292,2483,2527,2485],0); -ELEMENTS[71803] = Fluid3D([12960,13498,14148,13309],0); -ELEMENTS[71804] = Fluid3D([9151,9850,9109,8819],0); -ELEMENTS[71805] = Fluid3D([9382,10072,10475,9870],0); -ELEMENTS[71806] = Fluid3D([15764,16153,15423,15334],0); -ELEMENTS[71807] = Fluid3D([12887,13321,13801,13679],0); -ELEMENTS[71808] = Fluid3D([3675,3913,4101,4286],0); -ELEMENTS[71809] = Fluid3D([13922,13091,14197,12851],0); -ELEMENTS[71810] = Fluid3D([6065,5681,5935,6238],0); -ELEMENTS[71811] = Fluid3D([13118,13528,13390,12711],0); -ELEMENTS[71812] = Fluid3D([9230,9653,8518,8657],0); -ELEMENTS[71813] = Fluid3D([18172,17857,18103,17810],0); -ELEMENTS[71814] = Fluid3D([9402,8829,8890,8708],0); -ELEMENTS[71815] = Fluid3D([14630,15165,15188,15674],0); -ELEMENTS[71816] = Fluid3D([18304,18290,18185,18072],0); -ELEMENTS[71817] = Fluid3D([18304,18290,18072,18242],0); -ELEMENTS[71818] = Fluid3D([4016,4293,4541,4377],0); -ELEMENTS[71819] = Fluid3D([15774,15949,15709,15056],0); -ELEMENTS[71820] = Fluid3D([13902,14306,14792,13470],0); -ELEMENTS[71821] = Fluid3D([9244,9904,9201,9556],0); -ELEMENTS[71822] = Fluid3D([17246,17551,17234,17630],0); -ELEMENTS[71823] = Fluid3D([11102,10619,11513,12025],0); -ELEMENTS[71824] = Fluid3D([8524,7939,7082,7581],0); -ELEMENTS[71825] = Fluid3D([9190,8737,9780,9773],0); -ELEMENTS[71826] = Fluid3D([10058,9365,9220,9128],0); -ELEMENTS[71827] = Fluid3D([10058,9365,9128,9543],0); -ELEMENTS[71828] = Fluid3D([1932,2061,2200,2002],0); -ELEMENTS[71829] = Fluid3D([1932,2061,2002,1878],0); -ELEMENTS[71830] = Fluid3D([2061,2200,2002,2010],0); -ELEMENTS[71831] = Fluid3D([2061,2002,1878,2010],0); -ELEMENTS[71832] = Fluid3D([2002,1878,2010,1915],0); -ELEMENTS[71833] = Fluid3D([2010,2002,1915,2152],0); -ELEMENTS[71834] = Fluid3D([2002,1878,1915,1932],0); -ELEMENTS[71835] = Fluid3D([1915,2002,1932,2152],0); -ELEMENTS[71836] = Fluid3D([16632,16588,16194,16611],0); -ELEMENTS[71837] = Fluid3D([16194,16632,16611,16955],0); -ELEMENTS[71838] = Fluid3D([5469,5159,5146,4892],0); -ELEMENTS[71839] = Fluid3D([14472,13598,13530,14678],0); -ELEMENTS[71840] = Fluid3D([11749,11905,10888,11417],0); -ELEMENTS[71841] = Fluid3D([6645,6924,6134,6653],0); -ELEMENTS[71842] = Fluid3D([18530,18416,18531,18605],0); -ELEMENTS[71843] = Fluid3D([5428,5364,5657,5078],0); -ELEMENTS[71844] = Fluid3D([16186,16070,15898,16628],0); -ELEMENTS[71845] = Fluid3D([7283,7888,6968,6970],0); -ELEMENTS[71846] = Fluid3D([11871,12082,10451,12252],0); -ELEMENTS[71847] = Fluid3D([5946,5873,5341,5320],0); -ELEMENTS[71848] = Fluid3D([18461,18466,18321,18471],0); -ELEMENTS[71849] = Fluid3D([16533,16932,16975,16748],0); -ELEMENTS[71850] = Fluid3D([16533,16932,16748,16799],0); -ELEMENTS[71851] = Fluid3D([16975,16533,16748,16699],0); -ELEMENTS[71852] = Fluid3D([14598,14116,13571,13992],0); -ELEMENTS[71853] = Fluid3D([6443,6180,5479,6116],0); -ELEMENTS[71854] = Fluid3D([6443,6180,6116,7244],0); -ELEMENTS[71855] = Fluid3D([6180,5479,6116,6140],0); -ELEMENTS[71856] = Fluid3D([6116,6180,6140,7244],0); -ELEMENTS[71857] = Fluid3D([3716,3847,4207,3594],0); -ELEMENTS[71858] = Fluid3D([12549,12891,11823,12704],0); -ELEMENTS[71859] = Fluid3D([11823,12549,12704,12015],0); -ELEMENTS[71860] = Fluid3D([12549,12704,12015,13525],0); -ELEMENTS[71861] = Fluid3D([2978,3138,2700,2928],0); -ELEMENTS[71862] = Fluid3D([6730,6491,6132,6937],0); -ELEMENTS[71863] = Fluid3D([6730,6491,6937,7133],0); -ELEMENTS[71864] = Fluid3D([10969,11829,11680,11298],0); -ELEMENTS[71865] = Fluid3D([11680,10969,11298,10814],0); -ELEMENTS[71866] = Fluid3D([10969,11829,11298,11824],0); -ELEMENTS[71867] = Fluid3D([11308,10398,10560,11821],0); -ELEMENTS[71868] = Fluid3D([14938,14863,15313,14960],0); -ELEMENTS[71869] = Fluid3D([18305,18357,18444,18319],0); -ELEMENTS[71870] = Fluid3D([18305,18357,18319,18097],0); -ELEMENTS[71871] = Fluid3D([12989,13000,13084,13587],0); -ELEMENTS[71872] = Fluid3D([15168,15535,15046,14300],0); -ELEMENTS[71873] = Fluid3D([6748,6646,7585,7299],0); -ELEMENTS[71874] = Fluid3D([7832,8054,7402,7024],0); -ELEMENTS[71875] = Fluid3D([7402,7832,7024,7344],0); -ELEMENTS[71876] = Fluid3D([8440,7690,8049,8669],0); -ELEMENTS[71877] = Fluid3D([17451,17835,17649,17919],0); -ELEMENTS[71878] = Fluid3D([17835,17649,17919,17883],0); -ELEMENTS[71879] = Fluid3D([9702,8994,9999,9440],0); -ELEMENTS[71880] = Fluid3D([8994,9999,9440,8622],0); -ELEMENTS[71881] = Fluid3D([2710,2674,2391,2548],0); -ELEMENTS[71882] = Fluid3D([7052,7839,7950,7197],0); -ELEMENTS[71883] = Fluid3D([16973,16848,16542,16595],0); -ELEMENTS[71884] = Fluid3D([16973,16848,16595,17224],0); -ELEMENTS[71885] = Fluid3D([12128,11379,11044,11979],0); -ELEMENTS[71886] = Fluid3D([5810,5251,5822,5124],0); -ELEMENTS[71887] = Fluid3D([3187,3421,3203,3688],0); -ELEMENTS[71888] = Fluid3D([7517,8090,7737,6899],0); -ELEMENTS[71889] = Fluid3D([5742,5315,5195,5099],0); -ELEMENTS[71890] = Fluid3D([14932,15377,14780,15356],0); -ELEMENTS[71891] = Fluid3D([3970,4253,4802,4423],0); -ELEMENTS[71892] = Fluid3D([3970,4253,4423,4054],0); -ELEMENTS[71893] = Fluid3D([11656,10600,11350,11233],0); -ELEMENTS[71894] = Fluid3D([3479,3367,3071,2938],0); -ELEMENTS[71895] = Fluid3D([7806,7273,7133,6779],0); -ELEMENTS[71896] = Fluid3D([7273,7133,6779,6730],0); -ELEMENTS[71897] = Fluid3D([7133,7806,6779,7608],0); -ELEMENTS[71898] = Fluid3D([6779,7133,7608,6860],0); -ELEMENTS[71899] = Fluid3D([15364,15399,15385,16000],0); -ELEMENTS[71900] = Fluid3D([3537,3316,3597,3971],0); -ELEMENTS[71901] = Fluid3D([5924,5978,5694,6689],0); -ELEMENTS[71902] = Fluid3D([3723,4222,3815,3589],0); -ELEMENTS[71903] = Fluid3D([17244,16924,17355,17443],0); -ELEMENTS[71904] = Fluid3D([14769,14874,15546,15320],0); -ELEMENTS[71905] = Fluid3D([14769,14874,15320,14397],0); -ELEMENTS[71906] = Fluid3D([15416,14953,14743,15632],0); -ELEMENTS[71907] = Fluid3D([5076,5323,5124,5828],0); -ELEMENTS[71908] = Fluid3D([7501,7475,6543,7213],0); -ELEMENTS[71909] = Fluid3D([13170,12578,13434,12116],0); -ELEMENTS[71910] = Fluid3D([3893,4255,4221,4701],0); -ELEMENTS[71911] = Fluid3D([2701,2468,2828,2743],0); -ELEMENTS[71912] = Fluid3D([5941,5461,5158,5164],0); -ELEMENTS[71913] = Fluid3D([6970,6968,7991,7888],0); -ELEMENTS[71914] = Fluid3D([10400,10376,11244,10613],0); -ELEMENTS[71915] = Fluid3D([7236,6799,6984,7572],0); -ELEMENTS[71916] = Fluid3D([15478,15914,15767,16251],0); -ELEMENTS[71917] = Fluid3D([8543,8305,9247,8627],0); -ELEMENTS[71918] = Fluid3D([3050,2954,3175,3482],0); -ELEMENTS[71919] = Fluid3D([3502,3516,3065,3669],0); -ELEMENTS[71920] = Fluid3D([17417,17722,17787,17884],0); -ELEMENTS[71921] = Fluid3D([17420,17458,17329,17592],0); -ELEMENTS[71922] = Fluid3D([17458,17329,17592,17701],0); -ELEMENTS[71923] = Fluid3D([17458,17329,17701,17269],0); -ELEMENTS[71924] = Fluid3D([3949,4390,4159,4715],0); -ELEMENTS[71925] = Fluid3D([9213,9475,8428,8990],0); -ELEMENTS[71926] = Fluid3D([8604,7704,8491,7487],0); -ELEMENTS[71927] = Fluid3D([10861,11212,11764,11638],0); -ELEMENTS[71928] = Fluid3D([15332,15763,16048,15785],0); -ELEMENTS[71929] = Fluid3D([6748,6023,6646,5917],0); -ELEMENTS[71930] = Fluid3D([6748,6023,5917,6164],0); -ELEMENTS[71931] = Fluid3D([16380,16624,17108,16814],0); -ELEMENTS[71932] = Fluid3D([6152,6885,6738,7090],0); -ELEMENTS[71933] = Fluid3D([10752,11348,11666,12419],0); -ELEMENTS[71934] = Fluid3D([12153,11331,11701,11163],0); -ELEMENTS[71935] = Fluid3D([12153,11331,11163,11839],0); -ELEMENTS[71936] = Fluid3D([14180,13350,14546,14049],0); -ELEMENTS[71937] = Fluid3D([4773,4225,4172,4397],0); -ELEMENTS[71938] = Fluid3D([4225,4172,4397,3938],0); -ELEMENTS[71939] = Fluid3D([4773,4225,4397,4886],0); -ELEMENTS[71940] = Fluid3D([4397,4225,3938,3838],0); -ELEMENTS[71941] = Fluid3D([4436,4755,4010,4069],0); -ELEMENTS[71942] = Fluid3D([2593,2820,2932,2480],0); -ELEMENTS[71943] = Fluid3D([18280,18313,18067,18244],0); -ELEMENTS[71944] = Fluid3D([2998,3072,2756,2611],0); -ELEMENTS[71945] = Fluid3D([16591,16368,16147,15836],0); -ELEMENTS[71946] = Fluid3D([12950,13354,14076,13923],0); -ELEMENTS[71947] = Fluid3D([6152,5478,5603,5699],0); -ELEMENTS[71948] = Fluid3D([6152,5478,5699,6008],0); -ELEMENTS[71949] = Fluid3D([5478,5699,6008,5270],0); -ELEMENTS[71950] = Fluid3D([5478,5699,5270,4746],0); -ELEMENTS[71951] = Fluid3D([8247,8222,8792,7826],0); -ELEMENTS[71952] = Fluid3D([11925,11076,11984,12336],0); -ELEMENTS[71953] = Fluid3D([5381,5658,5089,5700],0); -ELEMENTS[71954] = Fluid3D([3168,3556,3720,3245],0); -ELEMENTS[71955] = Fluid3D([2463,2346,2219,2106],0); -ELEMENTS[71956] = Fluid3D([2346,2219,2106,2144],0); -ELEMENTS[71957] = Fluid3D([13626,14255,13619,14319],0); -ELEMENTS[71958] = Fluid3D([13626,14255,14319,14564],0); -ELEMENTS[71959] = Fluid3D([3838,3557,3881,3563],0); -ELEMENTS[71960] = Fluid3D([3557,3881,3563,3226],0); -ELEMENTS[71961] = Fluid3D([2022,1922,2038,2166],0); -ELEMENTS[71962] = Fluid3D([11059,11260,11086,11962],0); -ELEMENTS[71963] = Fluid3D([11059,11260,11962,12222],0); -ELEMENTS[71964] = Fluid3D([11059,11260,12222,11975],0); -ELEMENTS[71965] = Fluid3D([11059,11260,11975,10752],0); -ELEMENTS[71966] = Fluid3D([16341,16415,15827,15801],0); -ELEMENTS[71967] = Fluid3D([8548,9004,8995,9772],0); -ELEMENTS[71968] = Fluid3D([8548,9004,9772,9814],0); -ELEMENTS[71969] = Fluid3D([9004,9772,9814,9611],0); -ELEMENTS[71970] = Fluid3D([9004,9772,9611,10437],0); -ELEMENTS[71971] = Fluid3D([9004,9772,10437,9139],0); -ELEMENTS[71972] = Fluid3D([9004,9772,9139,8995],0); -ELEMENTS[71973] = Fluid3D([15226,15001,15419,14793],0); -ELEMENTS[71974] = Fluid3D([15226,15001,14793,14072],0); -ELEMENTS[71975] = Fluid3D([14758,15300,15212,14476],0); -ELEMENTS[71976] = Fluid3D([2555,2410,2512,2340],0); -ELEMENTS[71977] = Fluid3D([2512,2555,2340,2742],0); -ELEMENTS[71978] = Fluid3D([2555,2410,2340,2250],0); -ELEMENTS[71979] = Fluid3D([11043,10939,11076,11984],0); -ELEMENTS[71980] = Fluid3D([2481,2276,2649,2469],0); -ELEMENTS[71981] = Fluid3D([15109,14396,14735,15026],0); -ELEMENTS[71982] = Fluid3D([10404,10304,9920,9090],0); -ELEMENTS[71983] = Fluid3D([15602,14870,14907,15769],0); -ELEMENTS[71984] = Fluid3D([4850,5031,5530,5118],0); -ELEMENTS[71985] = Fluid3D([13985,13547,13478,14358],0); -ELEMENTS[71986] = Fluid3D([9014,9088,8645,8079],0); -ELEMENTS[71987] = Fluid3D([8645,9014,8079,8509],0); -ELEMENTS[71988] = Fluid3D([16913,17266,16943,16500],0); -ELEMENTS[71989] = Fluid3D([9229,8532,8533,8325],0); -ELEMENTS[71990] = Fluid3D([14627,14429,15102,13973],0); -ELEMENTS[71991] = Fluid3D([5221,5379,5142,4754],0); -ELEMENTS[71992] = Fluid3D([5221,5379,4754,5334],0); -ELEMENTS[71993] = Fluid3D([5123,5438,4875,4851],0); -ELEMENTS[71994] = Fluid3D([1862,2022,2038,2146],0); -ELEMENTS[71995] = Fluid3D([2022,2038,2146,2166],0); -ELEMENTS[71996] = Fluid3D([2038,2146,2166,2162],0); -ELEMENTS[71997] = Fluid3D([2038,2146,2162,2250],0); -ELEMENTS[71998] = Fluid3D([2166,2038,2162,1922],0); -ELEMENTS[71999] = Fluid3D([2038,1862,2146,1985],0); -ELEMENTS[72000] = Fluid3D([2146,2038,1985,2250],0); -ELEMENTS[72001] = Fluid3D([3838,4208,4309,4397],0); -ELEMENTS[72002] = Fluid3D([2859,2801,3050,3285],0); -ELEMENTS[72003] = Fluid3D([2801,3050,3285,3157],0); -ELEMENTS[72004] = Fluid3D([12734,11874,11582,11445],0); -ELEMENTS[72005] = Fluid3D([4754,4353,4873,4703],0); -ELEMENTS[72006] = Fluid3D([5715,6374,5812,6303],0); -ELEMENTS[72007] = Fluid3D([9153,9467,9151,8362],0); -ELEMENTS[72008] = Fluid3D([15485,14975,15246,14453],0); -ELEMENTS[72009] = Fluid3D([15481,14778,15194,15619],0); -ELEMENTS[72010] = Fluid3D([9968,9701,10719,11256],0); -ELEMENTS[72011] = Fluid3D([4030,4075,3569,3353],0); -ELEMENTS[72012] = Fluid3D([14621,14920,14082,14043],0); -ELEMENTS[72013] = Fluid3D([9437,9456,10393,9484],0); -ELEMENTS[72014] = Fluid3D([11325,11373,10813,10430],0); -ELEMENTS[72015] = Fluid3D([10714,11565,11336,11108],0); -ELEMENTS[72016] = Fluid3D([6219,6878,6406,6068],0); -ELEMENTS[72017] = Fluid3D([10386,11083,11460,10541],0); -ELEMENTS[72018] = Fluid3D([14791,14658,14400,13806],0); -ELEMENTS[72019] = Fluid3D([8497,7612,7566,8322],0); -ELEMENTS[72020] = Fluid3D([12087,11924,12751,11897],0); -ELEMENTS[72021] = Fluid3D([6055,5998,5457,5452],0); -ELEMENTS[72022] = Fluid3D([10113,10475,11186,11382],0); -ELEMENTS[72023] = Fluid3D([8334,8415,8230,7778],0); -ELEMENTS[72024] = Fluid3D([8230,8334,7778,9090],0); -ELEMENTS[72025] = Fluid3D([10561,10622,11541,10313],0); -ELEMENTS[72026] = Fluid3D([10561,10622,10313,10121],0); -ELEMENTS[72027] = Fluid3D([10622,10313,10121,11541],0); -ELEMENTS[72028] = Fluid3D([10561,10622,10121,9281],0); -ELEMENTS[72029] = Fluid3D([10121,10622,11541,10889],0); -ELEMENTS[72030] = Fluid3D([10121,10622,10889,10108],0); -ELEMENTS[72031] = Fluid3D([13365,13301,14483,13869],0); -ELEMENTS[72032] = Fluid3D([10911,10827,11133,10326],0); -ELEMENTS[72033] = Fluid3D([9132,9259,8764,9708],0); -ELEMENTS[72034] = Fluid3D([7023,6416,6234,6741],0); -ELEMENTS[72035] = Fluid3D([10660,9958,9533,9306],0); -ELEMENTS[72036] = Fluid3D([16207,15726,15999,16580],0); -ELEMENTS[72037] = Fluid3D([16207,15726,16580,15849],0); -ELEMENTS[72038] = Fluid3D([9463,8816,8612,8884],0); -ELEMENTS[72039] = Fluid3D([6796,6713,6300,6190],0); -ELEMENTS[72040] = Fluid3D([18241,17933,18034,18192],0); -ELEMENTS[72041] = Fluid3D([18241,17933,18192,18132],0); -ELEMENTS[72042] = Fluid3D([17250,16804,16917,16745],0); -ELEMENTS[72043] = Fluid3D([16804,16917,16745,16416],0); -ELEMENTS[72044] = Fluid3D([16916,16634,17240,16906],0); -ELEMENTS[72045] = Fluid3D([9106,8875,8570,9628],0); -ELEMENTS[72046] = Fluid3D([6568,6611,6828,6286],0); -ELEMENTS[72047] = Fluid3D([16950,17138,17430,17478],0); -ELEMENTS[72048] = Fluid3D([16950,17138,17478,17120],0); -ELEMENTS[72049] = Fluid3D([13499,13188,13158,13683],0); -ELEMENTS[72050] = Fluid3D([14243,13461,13962,13615],0); -ELEMENTS[72051] = Fluid3D([4485,4829,4731,4173],0); -ELEMENTS[72052] = Fluid3D([11363,11332,12292,12209],0); -ELEMENTS[72053] = Fluid3D([2224,2146,2022,1969],0); -ELEMENTS[72054] = Fluid3D([10098,10133,9971,10730],0); -ELEMENTS[72055] = Fluid3D([10133,9971,10730,10924],0); -ELEMENTS[72056] = Fluid3D([10730,10133,10924,11204],0); -ELEMENTS[72057] = Fluid3D([9971,10730,10924,11617],0); -ELEMENTS[72058] = Fluid3D([10730,10924,11617,11204],0); -ELEMENTS[72059] = Fluid3D([11617,10730,11204,10098],0); -ELEMENTS[72060] = Fluid3D([9971,10730,11617,10870],0); -ELEMENTS[72061] = Fluid3D([10730,11617,10870,10098],0); -ELEMENTS[72062] = Fluid3D([10098,10133,10730,11204],0); -ELEMENTS[72063] = Fluid3D([10133,9971,10924,9378],0); -ELEMENTS[72064] = Fluid3D([6538,6941,6668,7260],0); -ELEMENTS[72065] = Fluid3D([13390,12534,12711,12421],0); -ELEMENTS[72066] = Fluid3D([6656,6444,6143,6886],0); -ELEMENTS[72067] = Fluid3D([4153,4177,4638,4753],0); -ELEMENTS[72068] = Fluid3D([15380,14594,15177,15566],0); -ELEMENTS[72069] = Fluid3D([12252,12082,12503,12285],0); -ELEMENTS[72070] = Fluid3D([12503,12252,12285,12381],0); -ELEMENTS[72071] = Fluid3D([12285,12381,11871,12938],0); -ELEMENTS[72072] = Fluid3D([12285,12381,12938,12503],0); -ELEMENTS[72073] = Fluid3D([12938,12285,12503,12082],0); -ELEMENTS[72074] = Fluid3D([12252,12082,12285,11871],0); -ELEMENTS[72075] = Fluid3D([12252,12285,12381,11871],0); -ELEMENTS[72076] = Fluid3D([12082,11871,12332,12938],0); -ELEMENTS[72077] = Fluid3D([12938,12285,12082,11871],0); -ELEMENTS[72078] = Fluid3D([7041,7715,6985,8096],0); -ELEMENTS[72079] = Fluid3D([12703,12011,12754,13136],0); -ELEMENTS[72080] = Fluid3D([12141,11321,12675,11950],0); -ELEMENTS[72081] = Fluid3D([12141,11321,11950,11276],0); -ELEMENTS[72082] = Fluid3D([3919,4279,4441,3853],0); -ELEMENTS[72083] = Fluid3D([3919,4279,3853,3818],0); -ELEMENTS[72084] = Fluid3D([15455,15600,16192,16030],0); -ELEMENTS[72085] = Fluid3D([17008,17213,17462,17270],0); -ELEMENTS[72086] = Fluid3D([13302,12859,13339,12187],0); -ELEMENTS[72087] = Fluid3D([16889,17136,17236,17168],0); -ELEMENTS[72088] = Fluid3D([8605,8597,7676,8204],0); -ELEMENTS[72089] = Fluid3D([4339,4404,4375,5234],0); -ELEMENTS[72090] = Fluid3D([5176,5016,5481,5324],0); -ELEMENTS[72091] = Fluid3D([11885,11148,11923,11079],0); -ELEMENTS[72092] = Fluid3D([11522,11463,10856,11794],0); -ELEMENTS[72093] = Fluid3D([6944,6362,5953,6419],0); -ELEMENTS[72094] = Fluid3D([10529,11741,10701,11089],0); -ELEMENTS[72095] = Fluid3D([11556,12210,11985,12498],0); -ELEMENTS[72096] = Fluid3D([5581,6132,5855,6319],0); -ELEMENTS[72097] = Fluid3D([12805,13532,12664,12182],0); -ELEMENTS[72098] = Fluid3D([10796,10893,11947,11196],0); -ELEMENTS[72099] = Fluid3D([18412,18475,18543,18598],0); -ELEMENTS[72100] = Fluid3D([6065,6274,6922,7068],0); -ELEMENTS[72101] = Fluid3D([16176,16698,16558,16088],0); -ELEMENTS[72102] = Fluid3D([5479,5880,5143,5713],0); -ELEMENTS[72103] = Fluid3D([15322,15875,15107,15860],0); -ELEMENTS[72104] = Fluid3D([9985,10476,10130,9560],0); -ELEMENTS[72105] = Fluid3D([8152,8722,9200,8912],0); -ELEMENTS[72106] = Fluid3D([9200,8152,8912,7899],0); -ELEMENTS[72107] = Fluid3D([16731,16998,16512,16868],0); -ELEMENTS[72108] = Fluid3D([12207,11839,12264,11365],0); -ELEMENTS[72109] = Fluid3D([6244,6651,6996,6135],0); -ELEMENTS[72110] = Fluid3D([11704,10595,10894,10506],0); -ELEMENTS[72111] = Fluid3D([12592,12932,13051,12224],0); -ELEMENTS[72112] = Fluid3D([11216,10457,11336,11118],0); -ELEMENTS[72113] = Fluid3D([16593,17086,17131,17276],0); -ELEMENTS[72114] = Fluid3D([6306,5893,6661,6393],0); -ELEMENTS[72115] = Fluid3D([5893,6661,6393,5978],0); -ELEMENTS[72116] = Fluid3D([9786,9383,9563,8646],0); -ELEMENTS[72117] = Fluid3D([17153,17015,16702,16457],0); -ELEMENTS[72118] = Fluid3D([9242,9365,9903,8741],0); -ELEMENTS[72119] = Fluid3D([14354,14413,15021,14421],0); -ELEMENTS[72120] = Fluid3D([14354,14413,14421,13784],0); -ELEMENTS[72121] = Fluid3D([14758,14240,14875,14818],0); -ELEMENTS[72122] = Fluid3D([14642,14391,14528,15396],0); -ELEMENTS[72123] = Fluid3D([14441,14810,15206,14768],0); -ELEMENTS[72124] = Fluid3D([16316,16174,15695,15420],0); -ELEMENTS[72125] = Fluid3D([4467,4132,4637,4840],0); -ELEMENTS[72126] = Fluid3D([12180,12020,12524,12817],0); -ELEMENTS[72127] = Fluid3D([12020,12524,12817,13489],0); -ELEMENTS[72128] = Fluid3D([9319,9467,8427,9850],0); -ELEMENTS[72129] = Fluid3D([8792,8740,7826,8222],0); -ELEMENTS[72130] = Fluid3D([13865,13646,13292,12782],0); -ELEMENTS[72131] = Fluid3D([13646,13292,12782,13278],0); -ELEMENTS[72132] = Fluid3D([6062,5806,6187,6618],0); -ELEMENTS[72133] = Fluid3D([4102,4479,4077,4644],0); -ELEMENTS[72134] = Fluid3D([2681,2431,2852,2561],0); -ELEMENTS[72135] = Fluid3D([2267,2450,2493,2182],0); -ELEMENTS[72136] = Fluid3D([2267,2450,2182,2379],0); -ELEMENTS[72137] = Fluid3D([8906,8898,7919,7932],0); -ELEMENTS[72138] = Fluid3D([13471,12690,13669,12405],0); -ELEMENTS[72139] = Fluid3D([7539,8151,6938,7143],0); -ELEMENTS[72140] = Fluid3D([16129,15804,16298,16494],0); -ELEMENTS[72141] = Fluid3D([10897,11903,11851,11541],0); -ELEMENTS[72142] = Fluid3D([8216,7649,7608,7171],0); -ELEMENTS[72143] = Fluid3D([10006,10439,9954,11152],0); -ELEMENTS[72144] = Fluid3D([2644,2537,2884,2638],0); -ELEMENTS[72145] = Fluid3D([12863,12695,13133,13559],0); -ELEMENTS[72146] = Fluid3D([13210,12218,13244,12196],0); -ELEMENTS[72147] = Fluid3D([10153,9093,9011,10313],0); -ELEMENTS[72148] = Fluid3D([6449,6007,7016,5989],0); -ELEMENTS[72149] = Fluid3D([6449,6007,5989,5594],0); -ELEMENTS[72150] = Fluid3D([11237,12064,10688,11199],0); -ELEMENTS[72151] = Fluid3D([10688,11237,11199,10441],0); -ELEMENTS[72152] = Fluid3D([11199,10688,10441,10072],0); -ELEMENTS[72153] = Fluid3D([11199,10688,10072,11186],0); -ELEMENTS[72154] = Fluid3D([3943,3734,4186,4488],0); -ELEMENTS[72155] = Fluid3D([13992,14141,13579,13053],0); -ELEMENTS[72156] = Fluid3D([8178,8311,8189,7510],0); -ELEMENTS[72157] = Fluid3D([12239,11755,11046,12330],0); -ELEMENTS[72158] = Fluid3D([6808,6758,6078,6338],0); -ELEMENTS[72159] = Fluid3D([6078,6808,6338,5882],0); -ELEMENTS[72160] = Fluid3D([6808,6758,6338,7275],0); -ELEMENTS[72161] = Fluid3D([6758,6338,7275,6639],0); -ELEMENTS[72162] = Fluid3D([15574,15892,15184,14839],0); -ELEMENTS[72163] = Fluid3D([5294,5802,5975,5616],0); -ELEMENTS[72164] = Fluid3D([5294,5802,5616,5327],0); -ELEMENTS[72165] = Fluid3D([5294,5802,5327,4891],0); -ELEMENTS[72166] = Fluid3D([5327,5294,4891,5144],0); -ELEMENTS[72167] = Fluid3D([4891,5327,5144,5560],0); -ELEMENTS[72168] = Fluid3D([4891,5327,5560,5802],0); -ELEMENTS[72169] = Fluid3D([5327,5560,5802,5616],0); -ELEMENTS[72170] = Fluid3D([5327,5144,5560,5616],0); -ELEMENTS[72171] = Fluid3D([5327,5144,5616,5294],0); -ELEMENTS[72172] = Fluid3D([5802,5975,5616,6540],0); -ELEMENTS[72173] = Fluid3D([5975,5294,5616,5162],0); -ELEMENTS[72174] = Fluid3D([9398,8918,8574,9216],0); -ELEMENTS[72175] = Fluid3D([14711,15449,14808,15095],0); -ELEMENTS[72176] = Fluid3D([10595,9514,9847,10894],0); -ELEMENTS[72177] = Fluid3D([3942,3788,3748,3375],0); -ELEMENTS[72178] = Fluid3D([18670,18686,18675,18693],0); -ELEMENTS[72179] = Fluid3D([2081,2269,2337,2135],0); -ELEMENTS[72180] = Fluid3D([11894,11996,11583,10778],0); -ELEMENTS[72181] = Fluid3D([17490,17384,17374,17649],0); -ELEMENTS[72182] = Fluid3D([17374,17490,17649,17883],0); -ELEMENTS[72183] = Fluid3D([2432,2638,2527,2537],0); -ELEMENTS[72184] = Fluid3D([17241,17159,17502,17695],0); -ELEMENTS[72185] = Fluid3D([12218,13210,12699,12196],0); -ELEMENTS[72186] = Fluid3D([11443,11256,12203,11391],0); -ELEMENTS[72187] = Fluid3D([7794,7979,8884,8877],0); -ELEMENTS[72188] = Fluid3D([14729,15493,14772,15307],0); -ELEMENTS[72189] = Fluid3D([14772,14729,15307,14980],0); -ELEMENTS[72190] = Fluid3D([6861,6098,6438,7193],0); -ELEMENTS[72191] = Fluid3D([5086,5360,5452,5926],0); -ELEMENTS[72192] = Fluid3D([3431,3378,3074,3507],0); -ELEMENTS[72193] = Fluid3D([17518,17476,17377,16931],0); -ELEMENTS[72194] = Fluid3D([4754,5057,4305,4897],0); -ELEMENTS[72195] = Fluid3D([4754,5057,4897,5334],0); -ELEMENTS[72196] = Fluid3D([15085,15626,16044,15802],0); -ELEMENTS[72197] = Fluid3D([8318,8684,8672,8029],0); -ELEMENTS[72198] = Fluid3D([5705,5593,5379,6065],0); -ELEMENTS[72199] = Fluid3D([6337,6239,6755,6250],0); -ELEMENTS[72200] = Fluid3D([16926,17220,17080,16972],0); -ELEMENTS[72201] = Fluid3D([16926,17220,16972,16551],0); -ELEMENTS[72202] = Fluid3D([9185,9117,8650,9061],0); -ELEMENTS[72203] = Fluid3D([6619,6283,6044,5808],0); -ELEMENTS[72204] = Fluid3D([13263,13200,14184,14487],0); -ELEMENTS[72205] = Fluid3D([9724,9612,9836,10805],0); -ELEMENTS[72206] = Fluid3D([9612,9836,10805,10533],0); -ELEMENTS[72207] = Fluid3D([9836,10805,10533,10535],0); -ELEMENTS[72208] = Fluid3D([18098,17875,17731,17943],0); -ELEMENTS[72209] = Fluid3D([9889,9229,9748,10337],0); -ELEMENTS[72210] = Fluid3D([11045,11698,11855,11173],0); -ELEMENTS[72211] = Fluid3D([11045,11698,11173,10883],0); -ELEMENTS[72212] = Fluid3D([11045,11698,10883,10637],0); -ELEMENTS[72213] = Fluid3D([11698,11173,10883,12152],0); -ELEMENTS[72214] = Fluid3D([5805,5761,5476,5018],0); -ELEMENTS[72215] = Fluid3D([7919,7286,7121,6952],0); -ELEMENTS[72216] = Fluid3D([12782,13409,12617,12874],0); -ELEMENTS[72217] = Fluid3D([13409,12617,12874,13469],0); -ELEMENTS[72218] = Fluid3D([12617,12874,13469,12827],0); -ELEMENTS[72219] = Fluid3D([12617,12874,12827,11984],0); -ELEMENTS[72220] = Fluid3D([12617,12874,11984,12782],0); -ELEMENTS[72221] = Fluid3D([13469,12617,12827,13931],0); -ELEMENTS[72222] = Fluid3D([12782,13409,12874,13865],0); -ELEMENTS[72223] = Fluid3D([16733,16462,16237,15958],0); -ELEMENTS[72224] = Fluid3D([16462,16237,15958,16133],0); -ELEMENTS[72225] = Fluid3D([10456,10784,10502,11351],0); -ELEMENTS[72226] = Fluid3D([10456,10784,11351,11509],0); -ELEMENTS[72227] = Fluid3D([10784,10502,11351,11897],0); -ELEMENTS[72228] = Fluid3D([11351,10784,11897,11509],0); -ELEMENTS[72229] = Fluid3D([8969,8594,8297,7661],0); -ELEMENTS[72230] = Fluid3D([11947,11994,10893,11993],0); -ELEMENTS[72231] = Fluid3D([12598,12445,11719,12107],0); -ELEMENTS[72232] = Fluid3D([12445,11719,12107,11298],0); -ELEMENTS[72233] = Fluid3D([3351,3118,2817,3223],0); -ELEMENTS[72234] = Fluid3D([3351,3118,3223,3646],0); -ELEMENTS[72235] = Fluid3D([5373,4682,4780,4977],0); -ELEMENTS[72236] = Fluid3D([3907,3989,3745,3403],0); -ELEMENTS[72237] = Fluid3D([9020,8655,9266,8374],0); -ELEMENTS[72238] = Fluid3D([18017,18151,18291,18193],0); -ELEMENTS[72239] = Fluid3D([5398,5076,5582,5690],0); -ELEMENTS[72240] = Fluid3D([8017,7150,7305,7357],0); -ELEMENTS[72241] = Fluid3D([9505,9264,9696,10540],0); -ELEMENTS[72242] = Fluid3D([14354,14421,13315,13784],0); -ELEMENTS[72243] = Fluid3D([7291,7112,6372,6669],0); -ELEMENTS[72244] = Fluid3D([13378,12903,12682,12293],0); -ELEMENTS[72245] = Fluid3D([15812,16308,16406,16169],0); -ELEMENTS[72246] = Fluid3D([16992,17244,17355,17367],0); -ELEMENTS[72247] = Fluid3D([6123,6708,6450,5773],0); -ELEMENTS[72248] = Fluid3D([17179,17281,17160,16661],0); -ELEMENTS[72249] = Fluid3D([6926,6644,6521,6028],0); -ELEMENTS[72250] = Fluid3D([5704,6183,5694,6516],0); -ELEMENTS[72251] = Fluid3D([9547,9237,8630,8213],0); -ELEMENTS[72252] = Fluid3D([7675,8052,7250,7193],0); -ELEMENTS[72253] = Fluid3D([16195,16693,16457,16651],0); -ELEMENTS[72254] = Fluid3D([9791,9687,9284,10180],0); -ELEMENTS[72255] = Fluid3D([17701,17788,17364,17604],0); -ELEMENTS[72256] = Fluid3D([17788,17364,17604,17420],0); -ELEMENTS[72257] = Fluid3D([5166,5105,4975,4601],0); -ELEMENTS[72258] = Fluid3D([15851,15885,16250,16657],0); -ELEMENTS[72259] = Fluid3D([1931,1878,1818,2087],0); -ELEMENTS[72260] = Fluid3D([9556,8735,9201,9244],0); -ELEMENTS[72261] = Fluid3D([6583,6405,6188,5637],0); -ELEMENTS[72262] = Fluid3D([17895,17863,17565,17868],0); -ELEMENTS[72263] = Fluid3D([3852,4081,3570,3476],0); -ELEMENTS[72264] = Fluid3D([8543,7869,8305,8627],0); -ELEMENTS[72265] = Fluid3D([15538,15277,16095,15897],0); -ELEMENTS[72266] = Fluid3D([14974,15267,15432,15740],0); -ELEMENTS[72267] = Fluid3D([9813,9447,10287,8866],0); -ELEMENTS[72268] = Fluid3D([10344,9703,9375,8755],0); -ELEMENTS[72269] = Fluid3D([9285,9917,10270,10548],0); -ELEMENTS[72270] = Fluid3D([2010,2083,2152,1915],0); -ELEMENTS[72271] = Fluid3D([14751,14231,14583,15361],0); -ELEMENTS[72272] = Fluid3D([7629,6788,7266,7392],0); -ELEMENTS[72273] = Fluid3D([15016,15033,15616,15145],0); -ELEMENTS[72274] = Fluid3D([18471,18377,18560,18466],0); -ELEMENTS[72275] = Fluid3D([5880,6219,6406,6068],0); -ELEMENTS[72276] = Fluid3D([9237,9275,8403,8349],0); -ELEMENTS[72277] = Fluid3D([10079,10582,9353,9516],0); -ELEMENTS[72278] = Fluid3D([11832,12673,11709,11115],0); -ELEMENTS[72279] = Fluid3D([5419,4864,5143,5077],0); -ELEMENTS[72280] = Fluid3D([7578,7043,6745,6637],0); -ELEMENTS[72281] = Fluid3D([16675,17094,17181,17280],0); -ELEMENTS[72282] = Fluid3D([17094,17181,17280,17639],0); -ELEMENTS[72283] = Fluid3D([18051,17971,17858,18110],0); -ELEMENTS[72284] = Fluid3D([5852,6173,5848,5456],0); -ELEMENTS[72285] = Fluid3D([11310,12144,12466,11421],0); -ELEMENTS[72286] = Fluid3D([15832,15383,15439,15860],0); -ELEMENTS[72287] = Fluid3D([12099,12438,13046,12738],0); -ELEMENTS[72288] = Fluid3D([15410,15275,15053,15881],0); -ELEMENTS[72289] = Fluid3D([18216,18228,18202,18423],0); -ELEMENTS[72290] = Fluid3D([18419,18482,18279,18476],0); -ELEMENTS[72291] = Fluid3D([13717,12822,13673,13451],0); -ELEMENTS[72292] = Fluid3D([4723,5295,5223,5524],0); -ELEMENTS[72293] = Fluid3D([6758,7275,7051,6639],0); -ELEMENTS[72294] = Fluid3D([10823,11158,11754,12095],0); -ELEMENTS[72295] = Fluid3D([15179,14895,14387,14870],0); -ELEMENTS[72296] = Fluid3D([14387,15179,14870,14467],0); -ELEMENTS[72297] = Fluid3D([10498,10470,9898,10503],0); -ELEMENTS[72298] = Fluid3D([10728,9687,10475,10319],0); -ELEMENTS[72299] = Fluid3D([18470,18347,18374,18536],0); -ELEMENTS[72300] = Fluid3D([3647,3480,3135,3437],0); -ELEMENTS[72301] = Fluid3D([12729,12194,13204,12019],0); -ELEMENTS[72302] = Fluid3D([12076,11374,10454,11460],0); -ELEMENTS[72303] = Fluid3D([9275,9237,9056,8349],0); -ELEMENTS[72304] = Fluid3D([15701,16123,16263,15457],0); -ELEMENTS[72305] = Fluid3D([15701,16123,15457,15639],0); -ELEMENTS[72306] = Fluid3D([3786,3913,4390,4506],0); -ELEMENTS[72307] = Fluid3D([3913,4390,4506,4159],0); -ELEMENTS[72308] = Fluid3D([18486,18413,18582,18521],0); -ELEMENTS[72309] = Fluid3D([12011,12703,12366,13136],0); -ELEMENTS[72310] = Fluid3D([13207,12538,13272,12801],0); -ELEMENTS[72311] = Fluid3D([16954,16893,17354,17255],0); -ELEMENTS[72312] = Fluid3D([16954,16893,17255,16871],0); -ELEMENTS[72313] = Fluid3D([16893,17255,16871,17264],0); -ELEMENTS[72314] = Fluid3D([16893,17255,17264,17354],0); -ELEMENTS[72315] = Fluid3D([17354,16954,17255,17241],0); -ELEMENTS[72316] = Fluid3D([5886,6421,6162,5801],0); -ELEMENTS[72317] = Fluid3D([4644,4577,5139,4977],0); -ELEMENTS[72318] = Fluid3D([4003,3860,3431,3916],0); -ELEMENTS[72319] = Fluid3D([16381,16777,17130,16963],0); -ELEMENTS[72320] = Fluid3D([16381,16777,16963,17111],0); -ELEMENTS[72321] = Fluid3D([13915,14430,14861,14657],0); -ELEMENTS[72322] = Fluid3D([4994,5592,5368,5508],0); -ELEMENTS[72323] = Fluid3D([9870,10441,10072,10998],0); -ELEMENTS[72324] = Fluid3D([18094,17914,18000,17688],0); -ELEMENTS[72325] = Fluid3D([2509,2729,2988,2649],0); -ELEMENTS[72326] = Fluid3D([6953,6464,7472,6302],0); -ELEMENTS[72327] = Fluid3D([12022,11269,11312,12487],0); -ELEMENTS[72328] = Fluid3D([12022,11269,12487,11589],0); -ELEMENTS[72329] = Fluid3D([11312,12022,12487,11515],0); -ELEMENTS[72330] = Fluid3D([15912,15623,15376,15584],0); -ELEMENTS[72331] = Fluid3D([15376,15912,15584,16296],0); -ELEMENTS[72332] = Fluid3D([12379,12387,13304,12405],0); -ELEMENTS[72333] = Fluid3D([15072,14908,14311,14764],0); -ELEMENTS[72334] = Fluid3D([5100,5077,5659,5143],0); -ELEMENTS[72335] = Fluid3D([5370,4870,5771,5524],0); -ELEMENTS[72336] = Fluid3D([16634,17084,17240,17077],0); -ELEMENTS[72337] = Fluid3D([12708,13226,13098,13835],0); -ELEMENTS[72338] = Fluid3D([13897,13639,13328,13221],0); -ELEMENTS[72339] = Fluid3D([15842,15364,15856,15020],0); -ELEMENTS[72340] = Fluid3D([17073,17208,16735,16709],0); -ELEMENTS[72341] = Fluid3D([17765,17906,17681,17384],0); -ELEMENTS[72342] = Fluid3D([6656,6500,7477,7123],0); -ELEMENTS[72343] = Fluid3D([9685,10668,10249,9837],0); -ELEMENTS[72344] = Fluid3D([3209,3520,3743,3566],0); -ELEMENTS[72345] = Fluid3D([5415,5309,5843,5945],0); -ELEMENTS[72346] = Fluid3D([14195,14141,13691,13027],0); -ELEMENTS[72347] = Fluid3D([17032,16644,16922,17365],0); -ELEMENTS[72348] = Fluid3D([6795,6897,5982,5945],0); -ELEMENTS[72349] = Fluid3D([12812,12703,11545,12754],0); -ELEMENTS[72350] = Fluid3D([16186,16358,16681,16398],0); -ELEMENTS[72351] = Fluid3D([5566,5824,5298,6069],0); -ELEMENTS[72352] = Fluid3D([3525,3204,3383,3367],0); -ELEMENTS[72353] = Fluid3D([3525,3204,3367,3660],0); -ELEMENTS[72354] = Fluid3D([3313,3036,3009,2804],0); -ELEMENTS[72355] = Fluid3D([3036,3009,2804,2747],0); -ELEMENTS[72356] = Fluid3D([6556,6715,6471,5936],0); -ELEMENTS[72357] = Fluid3D([8597,8364,7676,7969],0); -ELEMENTS[72358] = Fluid3D([7676,8597,7969,8204],0); -ELEMENTS[72359] = Fluid3D([13484,14185,13027,13579],0); -ELEMENTS[72360] = Fluid3D([15177,15294,15566,14594],0); -ELEMENTS[72361] = Fluid3D([15333,14985,14770,14216],0); -ELEMENTS[72362] = Fluid3D([18653,18603,18571,18596],0); -ELEMENTS[72363] = Fluid3D([7143,6910,8007,7657],0); -ELEMENTS[72364] = Fluid3D([15331,15732,15065,15046],0); -ELEMENTS[72365] = Fluid3D([5385,5250,4637,5358],0); -ELEMENTS[72366] = Fluid3D([18075,17946,18175,18149],0); -ELEMENTS[72367] = Fluid3D([16882,17328,16991,17310],0); -ELEMENTS[72368] = Fluid3D([2620,2823,3052,2947],0); -ELEMENTS[72369] = Fluid3D([14553,15028,15330,14427],0); -ELEMENTS[72370] = Fluid3D([13716,14477,14157,14837],0); -ELEMENTS[72371] = Fluid3D([14477,14157,14837,15056],0); -ELEMENTS[72372] = Fluid3D([8607,7908,7648,9117],0); -ELEMENTS[72373] = Fluid3D([9255,9474,10503,9567],0); -ELEMENTS[72374] = Fluid3D([14598,14774,15022,15414],0); -ELEMENTS[72375] = Fluid3D([16915,16960,17177,16581],0); -ELEMENTS[72376] = Fluid3D([7372,6523,6855,6190],0); -ELEMENTS[72377] = Fluid3D([3787,3959,4302,4292],0); -ELEMENTS[72378] = Fluid3D([3247,2957,2777,3075],0); -ELEMENTS[72379] = Fluid3D([14347,14165,14684,15005],0); -ELEMENTS[72380] = Fluid3D([11421,10376,11488,10504],0); -ELEMENTS[72381] = Fluid3D([5572,5374,4756,4840],0); -ELEMENTS[72382] = Fluid3D([12181,12625,12036,11904],0); -ELEMENTS[72383] = Fluid3D([9664,10378,9330,10959],0); -ELEMENTS[72384] = Fluid3D([9621,8905,9902,9774],0); -ELEMENTS[72385] = Fluid3D([12214,12036,12181,13097],0); -ELEMENTS[72386] = Fluid3D([5952,5803,5742,5099],0); -ELEMENTS[72387] = Fluid3D([10325,10818,9708,10057],0); -ELEMENTS[72388] = Fluid3D([9708,10325,10057,9132],0); -ELEMENTS[72389] = Fluid3D([3036,3144,3009,2747],0); -ELEMENTS[72390] = Fluid3D([17542,17316,17729,17398],0); -ELEMENTS[72391] = Fluid3D([8192,7882,7234,7088],0); -ELEMENTS[72392] = Fluid3D([15214,14968,15169,15494],0); -ELEMENTS[72393] = Fluid3D([7396,7129,8140,8204],0); -ELEMENTS[72394] = Fluid3D([8140,7396,8204,8605],0); -ELEMENTS[72395] = Fluid3D([8204,8140,8605,9220],0); -ELEMENTS[72396] = Fluid3D([10545,9701,10269,11256],0); -ELEMENTS[72397] = Fluid3D([15915,16550,16462,16133],0); -ELEMENTS[72398] = Fluid3D([7447,6982,8098,7757],0); -ELEMENTS[72399] = Fluid3D([10089,9130,9546,9792],0); -ELEMENTS[72400] = Fluid3D([16608,16725,16997,17302],0); -ELEMENTS[72401] = Fluid3D([9940,9150,9472,9075],0); -ELEMENTS[72402] = Fluid3D([18674,18648,18639,18663],0); -ELEMENTS[72403] = Fluid3D([9923,9461,10130,9214],0); -ELEMENTS[72404] = Fluid3D([4451,4121,4314,3883],0); -ELEMENTS[72405] = Fluid3D([13221,13639,13708,14192],0); -ELEMENTS[72406] = Fluid3D([13022,13470,12805,13532],0); -ELEMENTS[72407] = Fluid3D([12805,13022,13532,12182],0); -ELEMENTS[72408] = Fluid3D([16023,16602,16718,16358],0); -ELEMENTS[72409] = Fluid3D([14515,13985,14946,14358],0); -ELEMENTS[72410] = Fluid3D([6554,6938,7760,7730],0); -ELEMENTS[72411] = Fluid3D([2292,2198,2163,2483],0); -ELEMENTS[72412] = Fluid3D([2292,2198,2483,2485],0); -ELEMENTS[72413] = Fluid3D([14837,15466,15709,15199],0); -ELEMENTS[72414] = Fluid3D([15466,15709,15199,15774],0); -ELEMENTS[72415] = Fluid3D([14837,15466,15199,15345],0); -ELEMENTS[72416] = Fluid3D([15466,15199,15345,15774],0); -ELEMENTS[72417] = Fluid3D([15345,15466,15774,15990],0); -ELEMENTS[72418] = Fluid3D([15345,15466,15990,16244],0); -ELEMENTS[72419] = Fluid3D([15709,14837,15199,15056],0); -ELEMENTS[72420] = Fluid3D([15199,15709,15056,15774],0); -ELEMENTS[72421] = Fluid3D([14837,15199,15056,14722],0); -ELEMENTS[72422] = Fluid3D([15199,15056,14722,15054],0); -ELEMENTS[72423] = Fluid3D([14722,15199,15054,15345],0); -ELEMENTS[72424] = Fluid3D([15056,15199,15774,15054],0); -ELEMENTS[72425] = Fluid3D([18460,18315,18512,18443],0); -ELEMENTS[72426] = Fluid3D([8398,7572,8246,7465],0); -ELEMENTS[72427] = Fluid3D([6223,5594,6040,6449],0); -ELEMENTS[72428] = Fluid3D([14906,14418,13780,14220],0); -ELEMENTS[72429] = Fluid3D([14418,13780,14220,14242],0); -ELEMENTS[72430] = Fluid3D([4225,4067,3591,3563],0); -ELEMENTS[72431] = Fluid3D([17639,17181,17459,17094],0); -ELEMENTS[72432] = Fluid3D([8302,9216,8918,9310],0); -ELEMENTS[72433] = Fluid3D([13740,13410,14501,13445],0); -ELEMENTS[72434] = Fluid3D([14501,13740,13445,14439],0); -ELEMENTS[72435] = Fluid3D([14501,13740,14439,14834],0); -ELEMENTS[72436] = Fluid3D([7298,7886,8509,8308],0); -ELEMENTS[72437] = Fluid3D([7298,7886,8308,8441],0); -ELEMENTS[72438] = Fluid3D([7886,8308,8441,8510],0); -ELEMENTS[72439] = Fluid3D([8308,8441,8510,9135],0); -ELEMENTS[72440] = Fluid3D([8441,8510,9135,7886],0); -ELEMENTS[72441] = Fluid3D([7886,8308,8510,8509],0); -ELEMENTS[72442] = Fluid3D([8510,8308,9135,8509],0); -ELEMENTS[72443] = Fluid3D([9135,8510,8509,7886],0); -ELEMENTS[72444] = Fluid3D([4699,4579,4746,4307],0); -ELEMENTS[72445] = Fluid3D([14569,15181,14140,14139],0); -ELEMENTS[72446] = Fluid3D([12501,12583,12448,13038],0); -ELEMENTS[72447] = Fluid3D([12501,12583,13038,13483],0); -ELEMENTS[72448] = Fluid3D([5179,4746,4655,4700],0); -ELEMENTS[72449] = Fluid3D([14584,14365,15029,15469],0); -ELEMENTS[72450] = Fluid3D([14533,14026,13812,13410],0); -ELEMENTS[72451] = Fluid3D([8261,8710,7470,8426],0); -ELEMENTS[72452] = Fluid3D([16053,15977,15545,15313],0); -ELEMENTS[72453] = Fluid3D([9204,9474,10178,9649],0); -ELEMENTS[72454] = Fluid3D([18313,18062,18067,18244],0); -ELEMENTS[72455] = Fluid3D([13390,14126,14257,14246],0); -ELEMENTS[72456] = Fluid3D([7603,6976,7635,7882],0); -ELEMENTS[72457] = Fluid3D([17159,17502,17071,17012],0); -ELEMENTS[72458] = Fluid3D([17071,17159,17012,16707],0); -ELEMENTS[72459] = Fluid3D([9834,8852,9633,10114],0); -ELEMENTS[72460] = Fluid3D([7871,7657,6910,7194],0); -ELEMENTS[72461] = Fluid3D([7871,7657,7194,7471],0); -ELEMENTS[72462] = Fluid3D([7657,6910,7194,7042],0); -ELEMENTS[72463] = Fluid3D([7194,7657,7042,7678],0); -ELEMENTS[72464] = Fluid3D([7042,7194,7678,7471],0); -ELEMENTS[72465] = Fluid3D([7042,7194,7471,6645],0); -ELEMENTS[72466] = Fluid3D([7042,7194,6645,6910],0); -ELEMENTS[72467] = Fluid3D([7194,7471,6645,7111],0); -ELEMENTS[72468] = Fluid3D([6645,7194,7111,6910],0); -ELEMENTS[72469] = Fluid3D([7194,7111,6910,7871],0); -ELEMENTS[72470] = Fluid3D([7194,7111,7871,7471],0); -ELEMENTS[72471] = Fluid3D([2539,2314,2431,2503],0); -ELEMENTS[72472] = Fluid3D([12487,12022,12548,11515],0); -ELEMENTS[72473] = Fluid3D([11615,10752,11666,12419],0); -ELEMENTS[72474] = Fluid3D([2672,2721,2529,2273],0); -ELEMENTS[72475] = Fluid3D([6829,7305,6537,7357],0); -ELEMENTS[72476] = Fluid3D([17556,17545,17898,18006],0); -ELEMENTS[72477] = Fluid3D([5532,5537,4956,5137],0); -ELEMENTS[72478] = Fluid3D([2819,2924,3245,3158],0); -ELEMENTS[72479] = Fluid3D([15633,15896,15381,16259],0); -ELEMENTS[72480] = Fluid3D([6261,7272,6677,6388],0); -ELEMENTS[72481] = Fluid3D([14879,15557,15139,15046],0); -ELEMENTS[72482] = Fluid3D([7763,8515,8140,7129],0); -ELEMENTS[72483] = Fluid3D([17099,17097,16580,16669],0); -ELEMENTS[72484] = Fluid3D([12833,12305,13204,12194],0); -ELEMENTS[72485] = Fluid3D([7445,7426,6776,7775],0); -ELEMENTS[72486] = Fluid3D([7849,7493,6908,7360],0); -ELEMENTS[72487] = Fluid3D([2743,2747,3144,3036],0); -ELEMENTS[72488] = Fluid3D([17333,17222,16967,16897],0); -ELEMENTS[72489] = Fluid3D([13310,13075,12444,12041],0); -ELEMENTS[72490] = Fluid3D([11975,12772,12389,13224],0); -ELEMENTS[72491] = Fluid3D([11975,12772,13224,12419],0); -ELEMENTS[72492] = Fluid3D([7978,8883,8340,8093],0); -ELEMENTS[72493] = Fluid3D([6113,5666,5719,5985],0); -ELEMENTS[72494] = Fluid3D([15971,15794,15991,16379],0); -ELEMENTS[72495] = Fluid3D([17665,17696,17550,17135],0); -ELEMENTS[72496] = Fluid3D([3065,2869,2955,3458],0); -ELEMENTS[72497] = Fluid3D([8508,8906,7919,7932],0); -ELEMENTS[72498] = Fluid3D([5303,4894,5778,5367],0); -ELEMENTS[72499] = Fluid3D([7035,6260,6909,6110],0); -ELEMENTS[72500] = Fluid3D([15269,14849,15586,14564],0); -ELEMENTS[72501] = Fluid3D([16177,16539,15717,16180],0); -ELEMENTS[72502] = Fluid3D([2948,3023,2674,2803],0); -ELEMENTS[72503] = Fluid3D([8304,7909,7791,8970],0); -ELEMENTS[72504] = Fluid3D([8304,7909,8970,9131],0); -ELEMENTS[72505] = Fluid3D([5442,5315,5992,6200],0); -ELEMENTS[72506] = Fluid3D([8282,8460,9516,9353],0); -ELEMENTS[72507] = Fluid3D([10072,9870,10998,10475],0); -ELEMENTS[72508] = Fluid3D([10998,10072,10475,11186],0); -ELEMENTS[72509] = Fluid3D([5593,4873,5620,5379],0); -ELEMENTS[72510] = Fluid3D([12167,12231,11391,11547],0); -ELEMENTS[72511] = Fluid3D([3470,3557,3838,3563],0); -ELEMENTS[72512] = Fluid3D([9620,9293,9773,10755],0); -ELEMENTS[72513] = Fluid3D([9139,9187,10304,10316],0); -ELEMENTS[72514] = Fluid3D([15801,15964,15684,16362],0); -ELEMENTS[72515] = Fluid3D([4922,4445,4940,4604],0); -ELEMENTS[72516] = Fluid3D([8334,8415,7778,7107],0); -ELEMENTS[72517] = Fluid3D([7622,7672,8029,8789],0); -ELEMENTS[72518] = Fluid3D([13430,12656,12563,12864],0); -ELEMENTS[72519] = Fluid3D([9316,10432,10372,9274],0); -ELEMENTS[72520] = Fluid3D([13374,12647,12378,12504],0); -ELEMENTS[72521] = Fluid3D([14464,15123,14415,14258],0); -ELEMENTS[72522] = Fluid3D([14415,14464,14258,13406],0); -ELEMENTS[72523] = Fluid3D([6801,6255,7274,7146],0); -ELEMENTS[72524] = Fluid3D([10509,11086,11860,11395],0); -ELEMENTS[72525] = Fluid3D([2593,2352,2820,2466],0); -ELEMENTS[72526] = Fluid3D([5790,5616,5144,4991],0); -ELEMENTS[72527] = Fluid3D([2092,2009,2037,1809],0); -ELEMENTS[72528] = Fluid3D([15096,14986,14645,15483],0); -ELEMENTS[72529] = Fluid3D([5166,4765,5105,4601],0); -ELEMENTS[72530] = Fluid3D([3589,3763,3356,3723],0); -ELEMENTS[72531] = Fluid3D([3589,3763,3723,4352],0); -ELEMENTS[72532] = Fluid3D([12378,12187,12105,12802],0); -ELEMENTS[72533] = Fluid3D([8653,9444,8452,9936],0); -ELEMENTS[72534] = Fluid3D([8594,8727,9638,8829],0); -ELEMENTS[72535] = Fluid3D([8594,8727,8829,7661],0); -ELEMENTS[72536] = Fluid3D([12937,13651,12601,13425],0); -ELEMENTS[72537] = Fluid3D([11505,12172,11658,12048],0); -ELEMENTS[72538] = Fluid3D([18257,17965,18279,18198],0); -ELEMENTS[72539] = Fluid3D([18279,18257,18198,18476],0); -ELEMENTS[72540] = Fluid3D([7717,6898,7641,7733],0); -ELEMENTS[72541] = Fluid3D([14854,14933,15658,15459],0); -ELEMENTS[72542] = Fluid3D([16389,16294,16732,16966],0); -ELEMENTS[72543] = Fluid3D([18254,18196,18372,18245],0); -ELEMENTS[72544] = Fluid3D([14765,14519,14145,14580],0); -ELEMENTS[72545] = Fluid3D([12421,11440,11610,11229],0); -ELEMENTS[72546] = Fluid3D([4068,3774,3900,3843],0); -ELEMENTS[72547] = Fluid3D([10577,10034,9438,9002],0); -ELEMENTS[72548] = Fluid3D([7849,8075,9074,8506],0); -ELEMENTS[72549] = Fluid3D([12493,11896,12023,11989],0); -ELEMENTS[72550] = Fluid3D([13369,12646,13097,12238],0); -ELEMENTS[72551] = Fluid3D([15577,16226,15892,16189],0); -ELEMENTS[72552] = Fluid3D([11589,12353,12170,12487],0); -ELEMENTS[72553] = Fluid3D([8567,8181,8976,9107],0); -ELEMENTS[72554] = Fluid3D([15475,15894,16291,15316],0); -ELEMENTS[72555] = Fluid3D([16287,16377,16046,15638],0); -ELEMENTS[72556] = Fluid3D([18096,18038,18063,17813],0); -ELEMENTS[72557] = Fluid3D([13517,13016,13146,12702],0); -ELEMENTS[72558] = Fluid3D([7411,7032,7661,6376],0); -ELEMENTS[72559] = Fluid3D([6943,6494,6709,7425],0); -ELEMENTS[72560] = Fluid3D([7041,7316,7907,8069],0); -ELEMENTS[72561] = Fluid3D([7041,7316,8069,8096],0); -ELEMENTS[72562] = Fluid3D([11445,10275,11028,11168],0); -ELEMENTS[72563] = Fluid3D([15054,14722,15010,15056],0); -ELEMENTS[72564] = Fluid3D([14100,14129,13400,12973],0); -ELEMENTS[72565] = Fluid3D([17413,17665,17102,17135],0); -ELEMENTS[72566] = Fluid3D([11860,11395,11441,10509],0); -ELEMENTS[72567] = Fluid3D([8792,7725,7606,8446],0); -ELEMENTS[72568] = Fluid3D([17283,17168,17515,17136],0); -ELEMENTS[72569] = Fluid3D([13136,13739,12754,12703],0); -ELEMENTS[72570] = Fluid3D([14115,14793,15073,14661],0); -ELEMENTS[72571] = Fluid3D([18046,18059,18221,17896],0); -ELEMENTS[72572] = Fluid3D([5613,6181,6332,5754],0); -ELEMENTS[72573] = Fluid3D([3351,3095,2964,2817],0); -ELEMENTS[72574] = Fluid3D([18240,18200,18098,17875],0); -ELEMENTS[72575] = Fluid3D([6063,6746,6296,6387],0); -ELEMENTS[72576] = Fluid3D([15050,15298,14538,15278],0); -ELEMENTS[72577] = Fluid3D([5507,5543,4965,4949],0); -ELEMENTS[72578] = Fluid3D([5507,5543,4949,5562],0); -ELEMENTS[72579] = Fluid3D([5543,4965,4949,4814],0); -ELEMENTS[72580] = Fluid3D([4305,4897,4489,4442],0); -ELEMENTS[72581] = Fluid3D([18004,18190,17925,18306],0); -ELEMENTS[72582] = Fluid3D([6376,6479,7025,7661],0); -ELEMENTS[72583] = Fluid3D([14540,14949,15477,15402],0); -ELEMENTS[72584] = Fluid3D([8915,8694,8021,7860],0); -ELEMENTS[72585] = Fluid3D([10673,10399,9464,9529],0); -ELEMENTS[72586] = Fluid3D([13851,14461,14674,14353],0); -ELEMENTS[72587] = Fluid3D([14216,13765,14334,14389],0); -ELEMENTS[72588] = Fluid3D([4854,4593,4352,4133],0); -ELEMENTS[72589] = Fluid3D([12875,12407,12044,11746],0); -ELEMENTS[72590] = Fluid3D([12875,12407,11746,12402],0); -ELEMENTS[72591] = Fluid3D([12875,12407,12402,12684],0); -ELEMENTS[72592] = Fluid3D([12407,12402,12684,11675],0); -ELEMENTS[72593] = Fluid3D([12407,12402,11675,11746],0); -ELEMENTS[72594] = Fluid3D([12402,12684,11675,11375],0); -ELEMENTS[72595] = Fluid3D([12402,11675,11746,12343],0); -ELEMENTS[72596] = Fluid3D([11675,12402,11375,12343],0); -ELEMENTS[72597] = Fluid3D([11746,12402,12343,12875],0); -ELEMENTS[72598] = Fluid3D([11675,12407,11746,12044],0); -ELEMENTS[72599] = Fluid3D([12402,11375,12343,12684],0); -ELEMENTS[72600] = Fluid3D([12343,12402,12684,12875],0); -ELEMENTS[72601] = Fluid3D([14214,13509,14361,14701],0); -ELEMENTS[72602] = Fluid3D([1861,1831,1717,1832],0); -ELEMENTS[72603] = Fluid3D([8132,7431,7692,7629],0); -ELEMENTS[72604] = Fluid3D([8265,8360,7657,7427],0); -ELEMENTS[72605] = Fluid3D([7781,8797,8576,8074],0); -ELEMENTS[72606] = Fluid3D([16939,16498,17111,16381],0); -ELEMENTS[72607] = Fluid3D([6201,5909,5942,5797],0); -ELEMENTS[72608] = Fluid3D([16210,15844,16204,15483],0); -ELEMENTS[72609] = Fluid3D([8739,7827,8103,7897],0); -ELEMENTS[72610] = Fluid3D([10803,11375,11675,11995],0); -ELEMENTS[72611] = Fluid3D([17782,17470,17787,17743],0); -ELEMENTS[72612] = Fluid3D([10998,11199,10441,10072],0); -ELEMENTS[72613] = Fluid3D([10998,11199,10072,11186],0); -ELEMENTS[72614] = Fluid3D([17105,17517,17317,17301],0); -ELEMENTS[72615] = Fluid3D([4750,4849,5152,5261],0); -ELEMENTS[72616] = Fluid3D([9382,8418,9331,9687],0); -ELEMENTS[72617] = Fluid3D([11501,12646,11954,12238],0); -ELEMENTS[72618] = Fluid3D([15434,14987,15274,15957],0); -ELEMENTS[72619] = Fluid3D([17251,16926,17045,16805],0); -ELEMENTS[72620] = Fluid3D([15767,15353,16251,16021],0); -ELEMENTS[72621] = Fluid3D([16251,15767,16021,16605],0); -ELEMENTS[72622] = Fluid3D([15767,15353,16021,15420],0); -ELEMENTS[72623] = Fluid3D([16021,15767,15420,16316],0); -ELEMENTS[72624] = Fluid3D([15353,16251,16021,15904],0); -ELEMENTS[72625] = Fluid3D([16251,16021,15904,16523],0); -ELEMENTS[72626] = Fluid3D([16251,16021,16523,16605],0); -ELEMENTS[72627] = Fluid3D([15904,16251,16523,16635],0); -ELEMENTS[72628] = Fluid3D([16021,15767,16316,16605],0); -ELEMENTS[72629] = Fluid3D([6875,6985,6755,7785],0); -ELEMENTS[72630] = Fluid3D([7943,8426,9215,8432],0); -ELEMENTS[72631] = Fluid3D([8640,9359,9175,9886],0); -ELEMENTS[72632] = Fluid3D([8640,9359,9886,8751],0); -ELEMENTS[72633] = Fluid3D([12450,12469,13331,13072],0); -ELEMENTS[72634] = Fluid3D([15105,15038,15469,15475],0); -ELEMENTS[72635] = Fluid3D([16676,17010,16503,16374],0); -ELEMENTS[72636] = Fluid3D([12307,11986,13196,12644],0); -ELEMENTS[72637] = Fluid3D([4479,4430,4949,4372],0); -ELEMENTS[72638] = Fluid3D([6447,6253,6575,7236],0); -ELEMENTS[72639] = Fluid3D([6575,6447,7236,7446],0); -ELEMENTS[72640] = Fluid3D([6966,6489,7403,7309],0); -ELEMENTS[72641] = Fluid3D([7454,6887,6618,6638],0); -ELEMENTS[72642] = Fluid3D([16411,16156,16076,15795],0); -ELEMENTS[72643] = Fluid3D([16076,16411,15795,16495],0); -ELEMENTS[72644] = Fluid3D([13637,12780,13207,12801],0); -ELEMENTS[72645] = Fluid3D([3949,4229,4390,4715],0); -ELEMENTS[72646] = Fluid3D([9129,9587,8284,9215],0); -ELEMENTS[72647] = Fluid3D([3555,3215,3546,3313],0); -ELEMENTS[72648] = Fluid3D([17875,18044,18081,18240],0); -ELEMENTS[72649] = Fluid3D([2483,2485,2805,2527],0); -ELEMENTS[72650] = Fluid3D([12818,12153,11839,13043],0); -ELEMENTS[72651] = Fluid3D([18354,18092,18112,18100],0); -ELEMENTS[72652] = Fluid3D([18092,18112,18100,17677],0); -ELEMENTS[72653] = Fluid3D([15079,15917,15122,15496],0); -ELEMENTS[72654] = Fluid3D([6641,6366,6696,5950],0); -ELEMENTS[72655] = Fluid3D([4440,4963,4890,4719],0); -ELEMENTS[72656] = Fluid3D([16825,17267,16865,17333],0); -ELEMENTS[72657] = Fluid3D([9531,8756,9413,8759],0); -ELEMENTS[72658] = Fluid3D([14992,14888,15440,14339],0); -ELEMENTS[72659] = Fluid3D([14992,14888,14339,14072],0); -ELEMENTS[72660] = Fluid3D([16535,16221,16705,16985],0); -ELEMENTS[72661] = Fluid3D([10943,11827,12318,11665],0); -ELEMENTS[72662] = Fluid3D([2135,2109,2337,2143],0); -ELEMENTS[72663] = Fluid3D([4135,3905,4319,3680],0); -ELEMENTS[72664] = Fluid3D([3781,4194,3716,3610],0); -ELEMENTS[72665] = Fluid3D([12101,11798,10967,11045],0); -ELEMENTS[72666] = Fluid3D([18377,18560,18466,18476],0); -ELEMENTS[72667] = Fluid3D([14193,14974,14630,15147],0); -ELEMENTS[72668] = Fluid3D([14974,14630,15147,15674],0); -ELEMENTS[72669] = Fluid3D([8745,9143,9261,10479],0); -ELEMENTS[72670] = Fluid3D([2193,2224,2072,1969],0); -ELEMENTS[72671] = Fluid3D([4181,3877,3780,4305],0); -ELEMENTS[72672] = Fluid3D([13755,13049,13279,12976],0); -ELEMENTS[72673] = Fluid3D([8775,8386,8653,7558],0); -ELEMENTS[72674] = Fluid3D([18014,17836,17841,17512],0); -ELEMENTS[72675] = Fluid3D([8764,7852,8270,9132],0); -ELEMENTS[72676] = Fluid3D([7715,7831,7785,6985],0); -ELEMENTS[72677] = Fluid3D([7715,7831,6985,8096],0); -ELEMENTS[72678] = Fluid3D([5896,5546,5288,5232],0); -ELEMENTS[72679] = Fluid3D([16906,16477,16716,16382],0); -ELEMENTS[72680] = Fluid3D([16906,16477,16382,16634],0); -ELEMENTS[72681] = Fluid3D([16150,16019,15530,16100],0); -ELEMENTS[72682] = Fluid3D([5625,5520,5531,4906],0); -ELEMENTS[72683] = Fluid3D([10190,11128,10628,10582],0); -ELEMENTS[72684] = Fluid3D([10628,10190,10582,9516],0); -ELEMENTS[72685] = Fluid3D([10500,10587,11566,11524],0); -ELEMENTS[72686] = Fluid3D([5856,6054,5218,5445],0); -ELEMENTS[72687] = Fluid3D([13695,13544,12624,12499],0); -ELEMENTS[72688] = Fluid3D([12472,12421,12711,11229],0); -ELEMENTS[72689] = Fluid3D([7717,6988,7733,8048],0); -ELEMENTS[72690] = Fluid3D([9255,8770,9567,9443],0); -ELEMENTS[72691] = Fluid3D([9917,10270,10548,11365],0); -ELEMENTS[72692] = Fluid3D([5455,5717,5612,6330],0); -ELEMENTS[72693] = Fluid3D([15979,15731,16014,16453],0); -ELEMENTS[72694] = Fluid3D([11964,11385,11236,10424],0); -ELEMENTS[72695] = Fluid3D([15705,16334,16006,15441],0); -ELEMENTS[72696] = Fluid3D([13718,13052,14103,13691],0); -ELEMENTS[72697] = Fluid3D([11345,12173,12523,12380],0); -ELEMENTS[72698] = Fluid3D([12173,12523,12380,13159],0); -ELEMENTS[72699] = Fluid3D([12798,12368,13099,11898],0); -ELEMENTS[72700] = Fluid3D([12798,12368,11898,11418],0); -ELEMENTS[72701] = Fluid3D([5373,5165,4682,4977],0); -ELEMENTS[72702] = Fluid3D([4811,4490,4206,4129],0); -ELEMENTS[72703] = Fluid3D([14706,14377,13988,14698],0); -ELEMENTS[72704] = Fluid3D([14706,14377,14698,15324],0); -ELEMENTS[72705] = Fluid3D([11719,12107,11298,10750],0); -ELEMENTS[72706] = Fluid3D([3074,2843,2610,2828],0); -ELEMENTS[72707] = Fluid3D([15294,14656,14815,14594],0); -ELEMENTS[72708] = Fluid3D([18268,18182,17993,18324],0); -ELEMENTS[72709] = Fluid3D([10702,10779,11203,9892],0); -ELEMENTS[72710] = Fluid3D([2264,2132,2350,2437],0); -ELEMENTS[72711] = Fluid3D([12292,13185,12327,12209],0); -ELEMENTS[72712] = Fluid3D([12327,12292,12209,11363],0); -ELEMENTS[72713] = Fluid3D([12107,11497,11298,10750],0); -ELEMENTS[72714] = Fluid3D([15284,15245,15801,15916],0); -ELEMENTS[72715] = Fluid3D([3239,3331,3020,3084],0); -ELEMENTS[72716] = Fluid3D([9690,9187,10404,9090],0); -ELEMENTS[72717] = Fluid3D([6187,6887,6618,6952],0); -ELEMENTS[72718] = Fluid3D([6187,6887,6952,7211],0); -ELEMENTS[72719] = Fluid3D([11158,11771,11743,11921],0); -ELEMENTS[72720] = Fluid3D([6349,6461,5822,5711],0); -ELEMENTS[72721] = Fluid3D([10318,10206,9498,9183],0); -ELEMENTS[72722] = Fluid3D([7599,7233,7130,6472],0); -ELEMENTS[72723] = Fluid3D([10270,9393,9509,9285],0); -ELEMENTS[72724] = Fluid3D([13610,14063,13718,13349],0); -ELEMENTS[72725] = Fluid3D([8209,7740,8649,8877],0); -ELEMENTS[72726] = Fluid3D([18397,18177,18288,18220],0); -ELEMENTS[72727] = Fluid3D([9183,9909,10318,9429],0); -ELEMENTS[72728] = Fluid3D([12882,12350,13266,12756],0); -ELEMENTS[72729] = Fluid3D([13059,12156,13004,12594],0); -ELEMENTS[72730] = Fluid3D([6994,7431,7578,7971],0); -ELEMENTS[72731] = Fluid3D([4959,4441,4279,5026],0); -ELEMENTS[72732] = Fluid3D([3863,3756,3330,3247],0); -ELEMENTS[72733] = Fluid3D([12658,12850,12246,13219],0); -ELEMENTS[72734] = Fluid3D([17486,17351,17757,17274],0); -ELEMENTS[72735] = Fluid3D([7465,7615,8398,7572],0); -ELEMENTS[72736] = Fluid3D([8745,9261,8195,8684],0); -ELEMENTS[72737] = Fluid3D([2544,2270,2287,2213],0); -ELEMENTS[72738] = Fluid3D([13518,14338,14262,14717],0); -ELEMENTS[72739] = Fluid3D([11411,11525,12619,12589],0); -ELEMENTS[72740] = Fluid3D([16009,16399,16531,15758],0); -ELEMENTS[72741] = Fluid3D([14425,14809,15018,13929],0); -ELEMENTS[72742] = Fluid3D([15491,15074,15014,14360],0); -ELEMENTS[72743] = Fluid3D([13146,13016,12525,12702],0); -ELEMENTS[72744] = Fluid3D([15060,15257,15604,15302],0); -ELEMENTS[72745] = Fluid3D([11055,11046,12222,11962],0); -ELEMENTS[72746] = Fluid3D([2961,2788,2590,3128],0); -ELEMENTS[72747] = Fluid3D([13593,13794,14178,12907],0); -ELEMENTS[72748] = Fluid3D([6024,5999,5242,5658],0); -ELEMENTS[72749] = Fluid3D([3073,3362,3094,2969],0); -ELEMENTS[72750] = Fluid3D([8372,7457,7538,7454],0); -ELEMENTS[72751] = Fluid3D([3810,3618,4044,3814],0); -ELEMENTS[72752] = Fluid3D([14562,15255,15433,15328],0); -ELEMENTS[72753] = Fluid3D([2961,2788,3128,3069],0); -ELEMENTS[72754] = Fluid3D([2961,2788,3069,3155],0); -ELEMENTS[72755] = Fluid3D([2961,2788,3155,2853],0); -ELEMENTS[72756] = Fluid3D([13471,13440,12718,13768],0); -ELEMENTS[72757] = Fluid3D([15624,15888,15524,16070],0); -ELEMENTS[72758] = Fluid3D([9929,9576,9514,9971],0); -ELEMENTS[72759] = Fluid3D([17624,17387,17401,17224],0); -ELEMENTS[72760] = Fluid3D([16200,16341,16073,16525],0); -ELEMENTS[72761] = Fluid3D([16341,16073,16525,16362],0); -ELEMENTS[72762] = Fluid3D([16073,16525,16362,15801],0); -ELEMENTS[72763] = Fluid3D([16341,16073,16362,15801],0); -ELEMENTS[72764] = Fluid3D([6063,6746,6387,5783],0); -ELEMENTS[72765] = Fluid3D([6193,5852,6601,5848],0); -ELEMENTS[72766] = Fluid3D([6431,6688,6245,6102],0); -ELEMENTS[72767] = Fluid3D([17634,17662,17660,17383],0); -ELEMENTS[72768] = Fluid3D([17510,17566,17766,17377],0); -ELEMENTS[72769] = Fluid3D([11460,12217,11083,11098],0); -ELEMENTS[72770] = Fluid3D([16315,16565,15878,15974],0); -ELEMENTS[72771] = Fluid3D([5310,6165,5846,5869],0); -ELEMENTS[72772] = Fluid3D([15160,15333,14216,14796],0); -ELEMENTS[72773] = Fluid3D([6009,6589,6543,6892],0); -ELEMENTS[72774] = Fluid3D([11162,12209,12327,11721],0); -ELEMENTS[72775] = Fluid3D([7725,6750,6900,6968],0); -ELEMENTS[72776] = Fluid3D([15626,15976,15398,15986],0); -ELEMENTS[72777] = Fluid3D([16898,17123,16750,17320],0); -ELEMENTS[72778] = Fluid3D([9488,10474,10552,9945],0); -ELEMENTS[72779] = Fluid3D([9488,10474,9945,8895],0); -ELEMENTS[72780] = Fluid3D([10474,10552,9945,10638],0); -ELEMENTS[72781] = Fluid3D([10498,9597,9474,10503],0); -ELEMENTS[72782] = Fluid3D([9686,8461,8475,9309],0); -ELEMENTS[72783] = Fluid3D([17036,17369,17096,16961],0); -ELEMENTS[72784] = Fluid3D([14559,14891,15436,14495],0); -ELEMENTS[72785] = Fluid3D([17301,17149,17028,16806],0); -ELEMENTS[72786] = Fluid3D([3144,2743,3036,3248],0); -ELEMENTS[72787] = Fluid3D([17591,17892,17638,17946],0); -ELEMENTS[72788] = Fluid3D([17591,17892,17946,17863],0); -ELEMENTS[72789] = Fluid3D([17591,17892,17863,17990],0); -ELEMENTS[72790] = Fluid3D([17892,17946,17863,18175],0); -ELEMENTS[72791] = Fluid3D([17892,17946,18175,17638],0); -ELEMENTS[72792] = Fluid3D([17591,17892,17990,17816],0); -ELEMENTS[72793] = Fluid3D([17892,17863,17990,18149],0); -ELEMENTS[72794] = Fluid3D([17863,17892,18175,18149],0); -ELEMENTS[72795] = Fluid3D([5498,6164,5947,5841],0); -ELEMENTS[72796] = Fluid3D([6830,6505,6680,7669],0); -ELEMENTS[72797] = Fluid3D([6618,7454,6638,7538],0); -ELEMENTS[72798] = Fluid3D([18049,17867,18068,17792],0); -ELEMENTS[72799] = Fluid3D([13765,13092,13274,12212],0); -ELEMENTS[72800] = Fluid3D([16365,16385,16570,15944],0); -ELEMENTS[72801] = Fluid3D([7908,7431,7712,6869],0); -ELEMENTS[72802] = Fluid3D([7059,7105,6531,6214],0); -ELEMENTS[72803] = Fluid3D([16400,16064,16121,15548],0); -ELEMENTS[72804] = Fluid3D([15652,15996,15473,15247],0); -ELEMENTS[72805] = Fluid3D([11508,12308,11401,11968],0); -ELEMENTS[72806] = Fluid3D([14077,13989,13103,13333],0); -ELEMENTS[72807] = Fluid3D([13940,13740,14427,14834],0); -ELEMENTS[72808] = Fluid3D([9652,8845,9377,9179],0); -ELEMENTS[72809] = Fluid3D([4420,4248,4944,4487],0); -ELEMENTS[72810] = Fluid3D([18452,18206,18370,18412],0); -ELEMENTS[72811] = Fluid3D([12181,11366,11246,11014],0); -ELEMENTS[72812] = Fluid3D([14417,14202,14975,14980],0); -ELEMENTS[72813] = Fluid3D([17010,16676,17131,16593],0); -ELEMENTS[72814] = Fluid3D([7826,8084,7725,6900],0); -ELEMENTS[72815] = Fluid3D([14501,14533,13812,13410],0); -ELEMENTS[72816] = Fluid3D([8954,8541,8551,9002],0); -ELEMENTS[72817] = Fluid3D([11900,11292,11605,12418],0); -ELEMENTS[72818] = Fluid3D([15638,15596,14868,15474],0); -ELEMENTS[72819] = Fluid3D([13269,12356,12707,12255],0); -ELEMENTS[72820] = Fluid3D([13269,12356,12255,12994],0); -ELEMENTS[72821] = Fluid3D([3607,3545,3109,3486],0); -ELEMENTS[72822] = Fluid3D([3607,3545,3486,3843],0); -ELEMENTS[72823] = Fluid3D([11327,11463,11794,10856],0); -ELEMENTS[72824] = Fluid3D([8487,7916,7595,7791],0); -ELEMENTS[72825] = Fluid3D([14459,13835,13952,14612],0); -ELEMENTS[72826] = Fluid3D([11736,12221,10927,11827],0); -ELEMENTS[72827] = Fluid3D([5661,5990,6239,6250],0); -ELEMENTS[72828] = Fluid3D([2211,2346,2144,2254],0); -ELEMENTS[72829] = Fluid3D([17322,16982,16857,16717],0); -ELEMENTS[72830] = Fluid3D([6148,5537,5711,5369],0); -ELEMENTS[72831] = Fluid3D([11670,12368,12069,11930],0); -ELEMENTS[72832] = Fluid3D([5277,5828,5076,5124],0); -ELEMENTS[72833] = Fluid3D([4872,5410,4583,4500],0); -ELEMENTS[72834] = Fluid3D([5311,5777,5965,5771],0); -ELEMENTS[72835] = Fluid3D([4733,4339,4992,5234],0); -ELEMENTS[72836] = Fluid3D([4992,4733,5234,5611],0); -ELEMENTS[72837] = Fluid3D([16744,16818,17235,16955],0); -ELEMENTS[72838] = Fluid3D([3895,3906,4372,3770],0); -ELEMENTS[72839] = Fluid3D([17468,17819,17610,17754],0); -ELEMENTS[72840] = Fluid3D([2501,2547,2250,2407],0); -ELEMENTS[72841] = Fluid3D([2501,2547,2407,2910],0); -ELEMENTS[72842] = Fluid3D([13019,13623,13322,12643],0); -ELEMENTS[72843] = Fluid3D([4978,5330,5093,4516],0); -ELEMENTS[72844] = Fluid3D([4978,5330,4516,5168],0); -ELEMENTS[72845] = Fluid3D([4978,5330,5168,5249],0); -ELEMENTS[72846] = Fluid3D([11715,11330,10373,10743],0); -ELEMENTS[72847] = Fluid3D([8587,7990,7756,8268],0); -ELEMENTS[72848] = Fluid3D([12377,12993,13369,13274],0); -ELEMENTS[72849] = Fluid3D([6248,6947,6251,6661],0); -ELEMENTS[72850] = Fluid3D([10794,9438,9795,10435],0); -ELEMENTS[72851] = Fluid3D([10287,9658,8866,9375],0); -ELEMENTS[72852] = Fluid3D([4033,4579,3983,4307],0); -ELEMENTS[72853] = Fluid3D([10040,9611,8778,9814],0); -ELEMENTS[72854] = Fluid3D([6918,7586,7359,7653],0); -ELEMENTS[72855] = Fluid3D([18036,18288,18177,18099],0); -ELEMENTS[72856] = Fluid3D([17943,17714,18092,17677],0); -ELEMENTS[72857] = Fluid3D([18306,18360,18117,18004],0); -ELEMENTS[72858] = Fluid3D([3351,3369,3783,3659],0); -ELEMENTS[72859] = Fluid3D([3351,3369,3659,3357],0); -ELEMENTS[72860] = Fluid3D([4380,3772,4003,4136],0); -ELEMENTS[72861] = Fluid3D([13880,14760,13883,14095],0); -ELEMENTS[72862] = Fluid3D([9924,10957,10384,10959],0); -ELEMENTS[72863] = Fluid3D([9924,10957,10959,10612],0); -ELEMENTS[72864] = Fluid3D([10957,10959,10612,11820],0); -ELEMENTS[72865] = Fluid3D([14986,15504,15483,15844],0); -ELEMENTS[72866] = Fluid3D([5456,5928,5644,6173],0); -ELEMENTS[72867] = Fluid3D([10010,11131,10680,10117],0); -ELEMENTS[72868] = Fluid3D([17160,16958,17179,16661],0); -ELEMENTS[72869] = Fluid3D([14294,13221,13639,13897],0); -ELEMENTS[72870] = Fluid3D([17201,16987,17193,17584],0); -ELEMENTS[72871] = Fluid3D([16712,16101,16348,16331],0); -ELEMENTS[72872] = Fluid3D([16667,17046,17031,16650],0); -ELEMENTS[72873] = Fluid3D([17648,17460,17542,17781],0); -ELEMENTS[72874] = Fluid3D([15601,15940,15025,15480],0); -ELEMENTS[72875] = Fluid3D([16241,15624,15524,16070],0); -ELEMENTS[72876] = Fluid3D([17698,17418,17277,17130],0); -ELEMENTS[72877] = Fluid3D([2610,2654,2577,2828],0); -ELEMENTS[72878] = Fluid3D([2577,2610,2828,3074],0); -ELEMENTS[72879] = Fluid3D([2610,2654,2828,2843],0); -ELEMENTS[72880] = Fluid3D([9351,9452,9860,10168],0); -ELEMENTS[72881] = Fluid3D([9351,9452,10168,8743],0); -ELEMENTS[72882] = Fluid3D([9452,9860,10168,10679],0); -ELEMENTS[72883] = Fluid3D([10168,9452,10679,9919],0); -ELEMENTS[72884] = Fluid3D([10168,9452,9919,8743],0); -ELEMENTS[72885] = Fluid3D([9452,9919,8743,9591],0); -ELEMENTS[72886] = Fluid3D([9452,9919,9591,10679],0); -ELEMENTS[72887] = Fluid3D([8743,9452,9591,8647],0); -ELEMENTS[72888] = Fluid3D([9452,9591,8647,9102],0); -ELEMENTS[72889] = Fluid3D([9591,9452,10679,9860],0); -ELEMENTS[72890] = Fluid3D([9591,9452,9860,9102],0); -ELEMENTS[72891] = Fluid3D([10679,10168,9919,11077],0); -ELEMENTS[72892] = Fluid3D([9919,10679,11077,9591],0); -ELEMENTS[72893] = Fluid3D([6162,6928,7198,6942],0); -ELEMENTS[72894] = Fluid3D([14841,13993,14589,14794],0); -ELEMENTS[72895] = Fluid3D([16446,16457,16862,17153],0); -ELEMENTS[72896] = Fluid3D([12305,11902,11301,12194],0); -ELEMENTS[72897] = Fluid3D([6022,6584,6815,7146],0); -ELEMENTS[72898] = Fluid3D([15539,15933,15930,16089],0); -ELEMENTS[72899] = Fluid3D([15539,15933,16089,16305],0); -ELEMENTS[72900] = Fluid3D([15933,15930,16089,16486],0); -ELEMENTS[72901] = Fluid3D([14908,14943,14938,13845],0); -ELEMENTS[72902] = Fluid3D([15121,15167,15485,15954],0); -ELEMENTS[72903] = Fluid3D([2919,2833,3062,2779],0); -ELEMENTS[72904] = Fluid3D([3291,2928,3206,3060],0); -ELEMENTS[72905] = Fluid3D([14429,14792,15102,13973],0); -ELEMENTS[72906] = Fluid3D([12976,12787,11944,12688],0); -ELEMENTS[72907] = Fluid3D([2652,2483,2298,2485],0); -ELEMENTS[72908] = Fluid3D([6298,5842,6163,6797],0); -ELEMENTS[72909] = Fluid3D([15056,14468,14477,14157],0); -ELEMENTS[72910] = Fluid3D([9965,9620,9773,10755],0); -ELEMENTS[72911] = Fluid3D([5873,5911,6632,6542],0); -ELEMENTS[72912] = Fluid3D([4075,4030,3644,3353],0); -ELEMENTS[72913] = Fluid3D([12421,13291,12711,13390],0); -ELEMENTS[72914] = Fluid3D([6899,6527,7517,6901],0); -ELEMENTS[72915] = Fluid3D([11286,11931,11820,12702],0); -ELEMENTS[72916] = Fluid3D([11931,11820,12702,11900],0); -ELEMENTS[72917] = Fluid3D([9161,8695,9645,9692],0); -ELEMENTS[72918] = Fluid3D([2816,2721,2863,3180],0); -ELEMENTS[72919] = Fluid3D([10283,9835,9252,9894],0); -ELEMENTS[72920] = Fluid3D([9590,10465,10362,11033],0); -ELEMENTS[72921] = Fluid3D([2141,2163,2198,2298],0); -ELEMENTS[72922] = Fluid3D([2198,2141,2298,2485],0); -ELEMENTS[72923] = Fluid3D([12930,13853,13945,13151],0); -ELEMENTS[72924] = Fluid3D([9818,10168,9919,8743],0); -ELEMENTS[72925] = Fluid3D([6914,7127,7537,6680],0); -ELEMENTS[72926] = Fluid3D([13479,14072,13487,14571],0); -ELEMENTS[72927] = Fluid3D([9613,10194,10298,11103],0); -ELEMENTS[72928] = Fluid3D([16517,16899,16577,16241],0); -ELEMENTS[72929] = Fluid3D([5561,5476,5118,5805],0); -ELEMENTS[72930] = Fluid3D([5561,5476,5805,6283],0); -ELEMENTS[72931] = Fluid3D([16929,17264,17160,16591],0); -ELEMENTS[72932] = Fluid3D([16655,16669,16580,17097],0); -ELEMENTS[72933] = Fluid3D([4156,4290,4280,3837],0); -ELEMENTS[72934] = Fluid3D([8195,8351,8645,9261],0); -ELEMENTS[72935] = Fluid3D([17096,16575,16892,16652],0); -ELEMENTS[72936] = Fluid3D([12000,10937,11973,10810],0); -ELEMENTS[72937] = Fluid3D([14678,14106,13598,13530],0); -ELEMENTS[72938] = Fluid3D([18231,18374,18382,18469],0); -ELEMENTS[72939] = Fluid3D([4339,4255,3820,3893],0); -ELEMENTS[72940] = Fluid3D([12503,12204,12603,11726],0); -ELEMENTS[72941] = Fluid3D([3699,3826,3676,3467],0); -ELEMENTS[72942] = Fluid3D([7813,7893,8569,7478],0); -ELEMENTS[72943] = Fluid3D([5287,5107,5078,5657],0); -ELEMENTS[72944] = Fluid3D([10912,11759,11686,12223],0); -ELEMENTS[72945] = Fluid3D([5880,5623,5143,5713],0); -ELEMENTS[72946] = Fluid3D([5542,5349,4957,4940],0); -ELEMENTS[72947] = Fluid3D([9969,9925,9108,8979],0); -ELEMENTS[72948] = Fluid3D([2037,1976,2186,2092],0); -ELEMENTS[72949] = Fluid3D([2037,1976,2092,1809],0); -ELEMENTS[72950] = Fluid3D([13565,13005,12481,13610],0); -ELEMENTS[72951] = Fluid3D([18610,18589,18534,18565],0); -ELEMENTS[72952] = Fluid3D([5791,6110,5400,6240],0); -ELEMENTS[72953] = Fluid3D([5885,5360,5756,5256],0); -ELEMENTS[72954] = Fluid3D([4973,5431,5664,4762],0); -ELEMENTS[72955] = Fluid3D([13053,13052,13691,12394],0); -ELEMENTS[72956] = Fluid3D([16341,16810,16525,16965],0); -ELEMENTS[72957] = Fluid3D([2688,2727,2978,3148],0); -ELEMENTS[72958] = Fluid3D([3478,3777,3880,3902],0); -ELEMENTS[72959] = Fluid3D([7420,7910,6934,6917],0); -ELEMENTS[72960] = Fluid3D([13881,14123,14729,14772],0); -ELEMENTS[72961] = Fluid3D([6608,6463,6093,5758],0); -ELEMENTS[72962] = Fluid3D([17118,17394,17452,17535],0); -ELEMENTS[72963] = Fluid3D([13591,12866,13642,13461],0); -ELEMENTS[72964] = Fluid3D([4977,4480,4450,4223],0); -ELEMENTS[72965] = Fluid3D([12085,12633,12961,12307],0); -ELEMENTS[72966] = Fluid3D([12633,12961,12307,13196],0); -ELEMENTS[72967] = Fluid3D([12307,12633,13196,12040],0); -ELEMENTS[72968] = Fluid3D([12307,12633,12040,11552],0); -ELEMENTS[72969] = Fluid3D([12085,12633,12307,11413],0); -ELEMENTS[72970] = Fluid3D([12633,12307,11413,11552],0); -ELEMENTS[72971] = Fluid3D([12961,12307,13196,12644],0); -ELEMENTS[72972] = Fluid3D([17576,17609,17817,18033],0); -ELEMENTS[72973] = Fluid3D([4916,5554,5546,5043],0); -ELEMENTS[72974] = Fluid3D([18230,18103,17979,18012],0); -ELEMENTS[72975] = Fluid3D([2792,3200,2828,3036],0); -ELEMENTS[72976] = Fluid3D([10363,11197,10524,10464],0); -ELEMENTS[72977] = Fluid3D([17291,17380,17603,17174],0); -ELEMENTS[72978] = Fluid3D([8414,8024,9208,9285],0); -ELEMENTS[72979] = Fluid3D([12880,13064,13947,13741],0); -ELEMENTS[72980] = Fluid3D([16699,16753,16580,16207],0); -ELEMENTS[72981] = Fluid3D([16753,16580,16207,15999],0); -ELEMENTS[72982] = Fluid3D([16699,16753,16207,16388],0); -ELEMENTS[72983] = Fluid3D([16753,16207,16388,15999],0); -ELEMENTS[72984] = Fluid3D([4489,4442,4015,4305],0); -ELEMENTS[72985] = Fluid3D([4442,4015,4305,3780],0); -ELEMENTS[72986] = Fluid3D([15408,15938,15500,15772],0); -ELEMENTS[72987] = Fluid3D([11230,10321,11397,10467],0); -ELEMENTS[72988] = Fluid3D([16378,16965,16341,16525],0); -ELEMENTS[72989] = Fluid3D([15824,16106,16409,15670],0); -ELEMENTS[72990] = Fluid3D([9418,9954,8720,9612],0); -ELEMENTS[72991] = Fluid3D([12591,12394,11924,11673],0); -ELEMENTS[72992] = Fluid3D([5299,5656,6146,5637],0); -ELEMENTS[72993] = Fluid3D([8794,8478,7849,9074],0); -ELEMENTS[72994] = Fluid3D([8794,8478,9074,9368],0); -ELEMENTS[72995] = Fluid3D([13003,13463,12684,12875],0); -ELEMENTS[72996] = Fluid3D([8245,8764,8270,8655],0); -ELEMENTS[72997] = Fluid3D([8270,8245,8655,7367],0); -ELEMENTS[72998] = Fluid3D([9644,8772,9608,8666],0); -ELEMENTS[72999] = Fluid3D([14198,14537,13878,14079],0); -ELEMENTS[73000] = Fluid3D([3512,4291,4034,3622],0); -ELEMENTS[73001] = Fluid3D([2819,2695,3038,3135],0); -ELEMENTS[73002] = Fluid3D([11801,10990,10640,10859],0); -ELEMENTS[73003] = Fluid3D([6062,6887,6179,6339],0); -ELEMENTS[73004] = Fluid3D([13288,13408,13037,13972],0); -ELEMENTS[73005] = Fluid3D([3431,3772,4003,3916],0); -ELEMENTS[73006] = Fluid3D([17102,17413,17135,17167],0); -ELEMENTS[73007] = Fluid3D([11838,11428,12245,11509],0); -ELEMENTS[73008] = Fluid3D([8027,8875,9148,8674],0); -ELEMENTS[73009] = Fluid3D([5879,6528,5777,6346],0); -ELEMENTS[73010] = Fluid3D([15478,14849,15767,15586],0); -ELEMENTS[73011] = Fluid3D([4169,3986,3844,3609],0); -ELEMENTS[73012] = Fluid3D([18502,18470,18378,18374],0); -ELEMENTS[73013] = Fluid3D([18378,18502,18374,18562],0); -ELEMENTS[73014] = Fluid3D([11298,12240,12445,11795],0); -ELEMENTS[73015] = Fluid3D([4763,5016,5324,5332],0); -ELEMENTS[73016] = Fluid3D([8471,8226,9506,9179],0); -ELEMENTS[73017] = Fluid3D([17647,17629,18032,17921],0); -ELEMENTS[73018] = Fluid3D([7181,6952,6618,7665],0); -ELEMENTS[73019] = Fluid3D([1917,2012,1854,1876],0); -ELEMENTS[73020] = Fluid3D([1917,2012,1876,2126],0); -ELEMENTS[73021] = Fluid3D([5100,5623,5143,5659],0); -ELEMENTS[73022] = Fluid3D([5100,5623,5659,5726],0); -ELEMENTS[73023] = Fluid3D([3542,3659,3966,3299],0); -ELEMENTS[73024] = Fluid3D([11454,10746,11439,10268],0); -ELEMENTS[73025] = Fluid3D([11454,10746,10268,10527],0); -ELEMENTS[73026] = Fluid3D([18011,18045,17948,17693],0); -ELEMENTS[73027] = Fluid3D([8201,8655,8374,7367],0); -ELEMENTS[73028] = Fluid3D([8820,8783,8455,9499],0); -ELEMENTS[73029] = Fluid3D([12921,13504,13827,12625],0); -ELEMENTS[73030] = Fluid3D([11681,12543,11108,12538],0); -ELEMENTS[73031] = Fluid3D([11681,12543,12538,12801],0); -ELEMENTS[73032] = Fluid3D([15677,15842,15831,15020],0); -ELEMENTS[73033] = Fluid3D([2060,2087,2010,1878],0); -ELEMENTS[73034] = Fluid3D([2010,2060,1878,2061],0); -ELEMENTS[73035] = Fluid3D([2060,1878,2061,1931],0); -ELEMENTS[73036] = Fluid3D([2060,1878,1931,2087],0); -ELEMENTS[73037] = Fluid3D([12581,12756,13266,12350],0); -ELEMENTS[73038] = Fluid3D([4467,4132,4840,4193],0); -ELEMENTS[73039] = Fluid3D([16210,15844,15483,15890],0); -ELEMENTS[73040] = Fluid3D([15483,16210,15890,15826],0); -ELEMENTS[73041] = Fluid3D([15483,16210,15826,16204],0); -ELEMENTS[73042] = Fluid3D([17022,17074,17271,17494],0); -ELEMENTS[73043] = Fluid3D([14100,14129,12973,13910],0); -ELEMENTS[73044] = Fluid3D([14100,14129,13910,14663],0); -ELEMENTS[73045] = Fluid3D([5498,5917,5841,5043],0); -ELEMENTS[73046] = Fluid3D([17821,17564,17575,17889],0); -ELEMENTS[73047] = Fluid3D([18158,18078,17938,17889],0); -ELEMENTS[73048] = Fluid3D([18158,18078,17889,18266],0); -ELEMENTS[73049] = Fluid3D([10675,9920,10947,10011],0); -ELEMENTS[73050] = Fluid3D([11972,12234,12079,11225],0); -ELEMENTS[73051] = Fluid3D([13722,13533,14386,14020],0); -ELEMENTS[73052] = Fluid3D([15860,16017,16480,16566],0); -ELEMENTS[73053] = Fluid3D([7477,8027,7123,7257],0); -ELEMENTS[73054] = Fluid3D([10487,11308,10560,9712],0); -ELEMENTS[73055] = Fluid3D([2648,2524,2844,2542],0); -ELEMENTS[73056] = Fluid3D([17743,17996,17787,17782],0); -ELEMENTS[73057] = Fluid3D([12325,12224,12592,13051],0); -ELEMENTS[73058] = Fluid3D([7910,8487,7595,8124],0); -ELEMENTS[73059] = Fluid3D([2098,2275,2010,2083],0); -ELEMENTS[73060] = Fluid3D([9641,8709,9401,10009],0); -ELEMENTS[73061] = Fluid3D([10469,10764,10005,11444],0); -ELEMENTS[73062] = Fluid3D([10469,10764,11444,11868],0); -ELEMENTS[73063] = Fluid3D([11974,12886,12288,12643],0); -ELEMENTS[73064] = Fluid3D([2710,2831,3128,2590],0); -ELEMENTS[73065] = Fluid3D([10062,9270,9025,8987],0); -ELEMENTS[73066] = Fluid3D([17170,17345,17212,16728],0); -ELEMENTS[73067] = Fluid3D([8483,9223,8708,8056],0); -ELEMENTS[73068] = Fluid3D([8483,9223,8056,8807],0); -ELEMENTS[73069] = Fluid3D([15913,15555,16277,16387],0); -ELEMENTS[73070] = Fluid3D([16277,15913,16387,16736],0); -ELEMENTS[73071] = Fluid3D([15913,15555,16387,16137],0); -ELEMENTS[73072] = Fluid3D([7493,7914,7069,6875],0); -ELEMENTS[73073] = Fluid3D([8512,9013,8052,9214],0); -ELEMENTS[73074] = Fluid3D([11820,12702,11978,11286],0); -ELEMENTS[73075] = Fluid3D([9176,9734,10182,9932],0); -ELEMENTS[73076] = Fluid3D([9171,9215,8426,8432],0); -ELEMENTS[73077] = Fluid3D([15344,14602,15188,14488],0); -ELEMENTS[73078] = Fluid3D([15344,14602,14488,14923],0); -ELEMENTS[73079] = Fluid3D([7234,6819,7122,7895],0); -ELEMENTS[73080] = Fluid3D([2667,2476,2542,2844],0); -ELEMENTS[73081] = Fluid3D([6878,7241,7421,7253],0); -ELEMENTS[73082] = Fluid3D([12372,12606,12301,13403],0); -ELEMENTS[73083] = Fluid3D([14599,15268,15144,14375],0); -ELEMENTS[73084] = Fluid3D([5916,5516,5191,5795],0); -ELEMENTS[73085] = Fluid3D([3908,4324,4497,4091],0); -ELEMENTS[73086] = Fluid3D([9115,9238,10098,8816],0); -ELEMENTS[73087] = Fluid3D([5402,4952,4918,5279],0); -ELEMENTS[73088] = Fluid3D([18559,18511,18438,18220],0); -ELEMENTS[73089] = Fluid3D([13390,13118,13295,14023],0); -ELEMENTS[73090] = Fluid3D([13739,13815,13883,13234],0); -ELEMENTS[73091] = Fluid3D([6132,5581,6203,6319],0); -ELEMENTS[73092] = Fluid3D([2537,2818,2638,2527],0); -ELEMENTS[73093] = Fluid3D([2771,2743,3144,3248],0); -ELEMENTS[73094] = Fluid3D([11296,10533,11826,10535],0); -ELEMENTS[73095] = Fluid3D([18305,18444,18271,18319],0); -ELEMENTS[73096] = Fluid3D([6910,6554,6072,7042],0); -ELEMENTS[73097] = Fluid3D([6082,5615,6368,6251],0); -ELEMENTS[73098] = Fluid3D([12354,12658,11478,12246],0); -ELEMENTS[73099] = Fluid3D([10662,10975,11600,11961],0); -ELEMENTS[73100] = Fluid3D([15954,16045,16146,16484],0); -ELEMENTS[73101] = Fluid3D([15954,16045,16484,16130],0); -ELEMENTS[73102] = Fluid3D([15955,15632,15416,15405],0); -ELEMENTS[73103] = Fluid3D([2109,2135,1966,2143],0); -ELEMENTS[73104] = Fluid3D([14498,14336,14985,14216],0); -ELEMENTS[73105] = Fluid3D([11710,11943,12496,11483],0); -ELEMENTS[73106] = Fluid3D([11730,12504,12647,12979],0); -ELEMENTS[73107] = Fluid3D([13896,13695,14734,14288],0); -ELEMENTS[73108] = Fluid3D([16502,16477,17077,16634],0); -ELEMENTS[73109] = Fluid3D([16502,16477,16634,15997],0); -ELEMENTS[73110] = Fluid3D([11225,11621,10696,11220],0); -ELEMENTS[73111] = Fluid3D([11225,11621,11220,12234],0); -ELEMENTS[73112] = Fluid3D([16253,16699,16915,16449],0); -ELEMENTS[73113] = Fluid3D([18307,18165,18290,18394],0); -ELEMENTS[73114] = Fluid3D([12041,12116,12432,13310],0); -ELEMENTS[73115] = Fluid3D([9971,10098,10730,10870],0); -ELEMENTS[73116] = Fluid3D([7971,7264,7578,6994],0); -ELEMENTS[73117] = Fluid3D([16219,16011,16620,16233],0); -ELEMENTS[73118] = Fluid3D([16219,16011,16233,15687],0); -ELEMENTS[73119] = Fluid3D([7123,7633,6584,7346],0); -ELEMENTS[73120] = Fluid3D([13588,13554,14023,13051],0); -ELEMENTS[73121] = Fluid3D([17599,17881,17690,17484],0); -ELEMENTS[73122] = Fluid3D([3215,3672,3546,3334],0); -ELEMENTS[73123] = Fluid3D([13921,14280,13274,14216],0); -ELEMENTS[73124] = Fluid3D([15690,15275,15838,15713],0); -ELEMENTS[73125] = Fluid3D([15014,15515,15006,14856],0); -ELEMENTS[73126] = Fluid3D([12739,12896,13711,13807],0); -ELEMENTS[73127] = Fluid3D([6957,7291,7413,6299],0); -ELEMENTS[73128] = Fluid3D([14318,14129,14663,13910],0); -ELEMENTS[73129] = Fluid3D([4835,4365,5033,4884],0); -ELEMENTS[73130] = Fluid3D([8035,7148,7189,7589],0); -ELEMENTS[73131] = Fluid3D([3448,3392,3949,3497],0); -ELEMENTS[73132] = Fluid3D([3448,3392,3497,3019],0); -ELEMENTS[73133] = Fluid3D([2593,2820,2480,2466],0); -ELEMENTS[73134] = Fluid3D([12011,11545,12754,12043],0); -ELEMENTS[73135] = Fluid3D([8090,7524,6901,7517],0); -ELEMENTS[73136] = Fluid3D([3794,4193,4132,4467],0); -ELEMENTS[73137] = Fluid3D([17963,17842,17569,17802],0); -ELEMENTS[73138] = Fluid3D([10618,10969,10814,10031],0); -ELEMENTS[73139] = Fluid3D([16706,17105,16379,16806],0); -ELEMENTS[73140] = Fluid3D([14835,14286,14255,14319],0); -ELEMENTS[73141] = Fluid3D([17758,17807,18027,17739],0); -ELEMENTS[73142] = Fluid3D([13765,12984,13271,13092],0); -ELEMENTS[73143] = Fluid3D([9563,9786,8646,8675],0); -ELEMENTS[73144] = Fluid3D([15109,15167,15485,14453],0); -ELEMENTS[73145] = Fluid3D([15449,14808,15095,15183],0); -ELEMENTS[73146] = Fluid3D([14808,15095,15183,14409],0); -ELEMENTS[73147] = Fluid3D([6104,5633,6149,6212],0); -ELEMENTS[73148] = Fluid3D([18060,17980,18333,18238],0); -ELEMENTS[73149] = Fluid3D([8250,7836,7556,7329],0); -ELEMENTS[73150] = Fluid3D([18244,18117,18315,18443],0); -ELEMENTS[73151] = Fluid3D([8594,8829,8297,7661],0); -ELEMENTS[73152] = Fluid3D([11567,11429,10466,10472],0); -ELEMENTS[73153] = Fluid3D([16034,16005,16651,16291],0); -ELEMENTS[73154] = Fluid3D([17356,17514,17550,17665],0); -ELEMENTS[73155] = Fluid3D([13354,12950,13334,13923],0); -ELEMENTS[73156] = Fluid3D([16500,16519,16913,16974],0); -ELEMENTS[73157] = Fluid3D([11898,10990,11418,10700],0); -ELEMENTS[73158] = Fluid3D([14600,14448,14654,15141],0); -ELEMENTS[73159] = Fluid3D([11891,11652,10818,11433],0); -ELEMENTS[73160] = Fluid3D([6351,6097,5858,5455],0); -ELEMENTS[73161] = Fluid3D([14628,13876,14285,14373],0); -ELEMENTS[73162] = Fluid3D([14628,13876,14373,13704],0); -ELEMENTS[73163] = Fluid3D([5352,5996,5316,5615],0); -ELEMENTS[73164] = Fluid3D([12238,12036,12625,11904],0); -ELEMENTS[73165] = Fluid3D([3781,3594,3716,4207],0); -ELEMENTS[73166] = Fluid3D([11899,11448,11095,10552],0); -ELEMENTS[73167] = Fluid3D([8192,8470,7929,7895],0); -ELEMENTS[73168] = Fluid3D([15503,15582,16306,15749],0); -ELEMENTS[73169] = Fluid3D([12370,11925,12336,12722],0); -ELEMENTS[73170] = Fluid3D([12336,12370,12722,13452],0); -ELEMENTS[73171] = Fluid3D([12761,13113,13612,13698],0); -ELEMENTS[73172] = Fluid3D([8008,7932,7429,8853],0); -ELEMENTS[73173] = Fluid3D([12324,12561,13202,13262],0); -ELEMENTS[73174] = Fluid3D([14926,14717,14338,15053],0); -ELEMENTS[73175] = Fluid3D([9677,10252,9054,10009],0); -ELEMENTS[73176] = Fluid3D([13081,12476,13609,13555],0); -ELEMENTS[73177] = Fluid3D([7142,7657,8360,7427],0); -ELEMENTS[73178] = Fluid3D([14572,14561,14182,13471],0); -ELEMENTS[73179] = Fluid3D([14279,13383,13866,13851],0); -ELEMENTS[73180] = Fluid3D([18178,17948,18219,17840],0); -ELEMENTS[73181] = Fluid3D([3852,3608,3219,3570],0); -ELEMENTS[73182] = Fluid3D([8910,8459,9756,9400],0); -ELEMENTS[73183] = Fluid3D([7408,8305,7869,7693],0); -ELEMENTS[73184] = Fluid3D([9225,8970,9793,10238],0); -ELEMENTS[73185] = Fluid3D([18080,17972,17874,17623],0); -ELEMENTS[73186] = Fluid3D([4351,4724,4259,4425],0); -ELEMENTS[73187] = Fluid3D([6790,6134,6924,6653],0); -ELEMENTS[73188] = Fluid3D([15600,15503,16155,16030],0); -ELEMENTS[73189] = Fluid3D([16694,17077,16795,16502],0); -ELEMENTS[73190] = Fluid3D([16795,16694,16502,16406],0); -ELEMENTS[73191] = Fluid3D([16694,17077,16502,16754],0); -ELEMENTS[73192] = Fluid3D([15015,15136,15536,15617],0); -ELEMENTS[73193] = Fluid3D([8024,8023,8161,9285],0); -ELEMENTS[73194] = Fluid3D([18163,18338,18188,18273],0); -ELEMENTS[73195] = Fluid3D([5309,4977,5228,5139],0); -ELEMENTS[73196] = Fluid3D([18555,18420,18541,18517],0); -ELEMENTS[73197] = Fluid3D([16070,15963,16628,16577],0); -ELEMENTS[73198] = Fluid3D([17727,17471,17293,17705],0); -ELEMENTS[73199] = Fluid3D([17727,17471,17705,17584],0); -ELEMENTS[73200] = Fluid3D([17471,17293,17705,17201],0); -ELEMENTS[73201] = Fluid3D([17705,17471,17201,17584],0); -ELEMENTS[73202] = Fluid3D([17471,17293,17201,16987],0); -ELEMENTS[73203] = Fluid3D([17201,17471,16987,17584],0); -ELEMENTS[73204] = Fluid3D([14141,13666,14469,13691],0); -ELEMENTS[73205] = Fluid3D([17453,17781,17487,17542],0); -ELEMENTS[73206] = Fluid3D([17781,17487,17542,17942],0); -ELEMENTS[73207] = Fluid3D([2743,2771,2792,3248],0); -ELEMENTS[73208] = Fluid3D([4486,4603,4592,5077],0); -ELEMENTS[73209] = Fluid3D([12664,11777,12038,12964],0); -ELEMENTS[73210] = Fluid3D([14429,14166,14792,13470],0); -ELEMENTS[73211] = Fluid3D([15457,15543,15639,16123],0); -ELEMENTS[73212] = Fluid3D([4352,4222,3723,3589],0); -ELEMENTS[73213] = Fluid3D([17003,16810,16695,17144],0); -ELEMENTS[73214] = Fluid3D([6516,6664,7329,6689],0); -ELEMENTS[73215] = Fluid3D([7329,6516,6689,7517],0); -ELEMENTS[73216] = Fluid3D([8668,7828,8968,8021],0); -ELEMENTS[73217] = Fluid3D([11495,11191,12138,12452],0); -ELEMENTS[73218] = Fluid3D([11495,11191,12452,11939],0); -ELEMENTS[73219] = Fluid3D([6987,6944,7258,6387],0); -ELEMENTS[73220] = Fluid3D([16994,16772,16465,16468],0); -ELEMENTS[73221] = Fluid3D([18411,18362,18363,18480],0); -ELEMENTS[73222] = Fluid3D([6832,6982,7244,7757],0); -ELEMENTS[73223] = Fluid3D([7244,6832,7757,6386],0); -ELEMENTS[73224] = Fluid3D([13545,12681,13366,13775],0); -ELEMENTS[73225] = Fluid3D([16723,16270,16933,16802],0); -ELEMENTS[73226] = Fluid3D([13686,13399,12917,12409],0); -ELEMENTS[73227] = Fluid3D([9833,10018,9205,8861],0); -ELEMENTS[73228] = Fluid3D([1811,1915,2009,1809],0); -ELEMENTS[73229] = Fluid3D([5324,4919,5332,5882],0); -ELEMENTS[73230] = Fluid3D([9764,8876,9892,9091],0); -ELEMENTS[73231] = Fluid3D([5978,5719,5675,5493],0); -ELEMENTS[73232] = Fluid3D([5606,5520,5036,5531],0); -ELEMENTS[73233] = Fluid3D([5994,6203,6768,6120],0); -ELEMENTS[73234] = Fluid3D([2649,2568,2509,2320],0); -ELEMENTS[73235] = Fluid3D([14587,14935,15280,15469],0); -ELEMENTS[73236] = Fluid3D([14850,15345,14722,15054],0); -ELEMENTS[73237] = Fluid3D([12350,11612,12581,11860],0); -ELEMENTS[73238] = Fluid3D([11826,11468,10535,10669],0); -ELEMENTS[73239] = Fluid3D([6861,6302,6332,7250],0); -ELEMENTS[73240] = Fluid3D([6332,6861,7250,7193],0); -ELEMENTS[73241] = Fluid3D([9464,9529,10119,10673],0); -ELEMENTS[73242] = Fluid3D([14298,14572,15209,14621],0); -ELEMENTS[73243] = Fluid3D([17048,17102,17392,17642],0); -ELEMENTS[73244] = Fluid3D([14466,13757,13999,13769],0); -ELEMENTS[73245] = Fluid3D([10541,10454,11460,10386],0); -ELEMENTS[73246] = Fluid3D([2254,2357,2518,2346],0); -ELEMENTS[73247] = Fluid3D([13989,13366,14012,14516],0); -ELEMENTS[73248] = Fluid3D([14288,14002,13843,14235],0); -ELEMENTS[73249] = Fluid3D([17613,17373,17060,17291],0); -ELEMENTS[73250] = Fluid3D([10470,11068,9917,11365],0); -ELEMENTS[73251] = Fluid3D([10470,11068,11365,11839],0); -ELEMENTS[73252] = Fluid3D([8245,7341,7367,7513],0); -ELEMENTS[73253] = Fluid3D([8245,7341,7513,8270],0); -ELEMENTS[73254] = Fluid3D([7513,8245,8270,7367],0); -ELEMENTS[73255] = Fluid3D([7341,7513,8270,7852],0); -ELEMENTS[73256] = Fluid3D([7513,8270,7852,7604],0); -ELEMENTS[73257] = Fluid3D([7513,8270,7604,7478],0); -ELEMENTS[73258] = Fluid3D([7341,7513,7852,7117],0); -ELEMENTS[73259] = Fluid3D([7513,8270,7478,7367],0); -ELEMENTS[73260] = Fluid3D([5040,5297,4912,5474],0); -ELEMENTS[73261] = Fluid3D([5297,4912,5474,4784],0); -ELEMENTS[73262] = Fluid3D([16389,16303,16749,17072],0); -ELEMENTS[73263] = Fluid3D([11567,11229,11604,12711],0); -ELEMENTS[73264] = Fluid3D([17974,17932,18174,18008],0); -ELEMENTS[73265] = Fluid3D([17974,17932,18008,17602],0); -ELEMENTS[73266] = Fluid3D([18008,17974,17602,17721],0); -ELEMENTS[73267] = Fluid3D([18008,17974,17721,18067],0); -ELEMENTS[73268] = Fluid3D([18008,17974,18067,18280],0); -ELEMENTS[73269] = Fluid3D([18174,17974,18008,18315],0); -ELEMENTS[73270] = Fluid3D([17974,18008,18315,18280],0); -ELEMENTS[73271] = Fluid3D([12040,11755,11552,12633],0); -ELEMENTS[73272] = Fluid3D([2201,2279,2480,2076],0); -ELEMENTS[73273] = Fluid3D([16750,17320,17163,16898],0); -ELEMENTS[73274] = Fluid3D([10255,10708,10529,11110],0); -ELEMENTS[73275] = Fluid3D([18201,18321,18461,18342],0); -ELEMENTS[73276] = Fluid3D([14156,13272,13879,13652],0); -ELEMENTS[73277] = Fluid3D([16700,16819,16303,16057],0); -ELEMENTS[73278] = Fluid3D([3255,3693,3061,3314],0); -ELEMENTS[73279] = Fluid3D([11323,10345,11120,10199],0); -ELEMENTS[73280] = Fluid3D([11323,10345,10199,10893],0); -ELEMENTS[73281] = Fluid3D([8426,8946,9129,9527],0); -ELEMENTS[73282] = Fluid3D([16027,15575,15607,15249],0); -ELEMENTS[73283] = Fluid3D([3074,2843,2828,2980],0); -ELEMENTS[73284] = Fluid3D([3064,3108,3223,2774],0); -ELEMENTS[73285] = Fluid3D([6532,6034,5853,5733],0); -ELEMENTS[73286] = Fluid3D([17575,17938,17821,17889],0); -ELEMENTS[73287] = Fluid3D([15572,15315,14878,15018],0); -ELEMENTS[73288] = Fluid3D([16800,17065,17039,17487],0); -ELEMENTS[73289] = Fluid3D([12157,12153,13079,13043],0); -ELEMENTS[73290] = Fluid3D([12157,12153,13043,11839],0); -ELEMENTS[73291] = Fluid3D([7990,8208,8268,9226],0); -ELEMENTS[73292] = Fluid3D([8299,8174,8257,8745],0); -ELEMENTS[73293] = Fluid3D([8174,8257,8745,7326],0); -ELEMENTS[73294] = Fluid3D([17479,17398,17736,17729],0); -ELEMENTS[73295] = Fluid3D([17479,17398,17729,17316],0); -ELEMENTS[73296] = Fluid3D([17398,17736,17729,17487],0); -ELEMENTS[73297] = Fluid3D([7268,6729,6311,6542],0); -ELEMENTS[73298] = Fluid3D([2749,2854,2517,2381],0); -ELEMENTS[73299] = Fluid3D([17296,17429,17674,17322],0); -ELEMENTS[73300] = Fluid3D([9261,9323,8745,10479],0); -ELEMENTS[73301] = Fluid3D([5370,5777,5771,6259],0); -ELEMENTS[73302] = Fluid3D([3398,3511,3751,3805],0); -ELEMENTS[73303] = Fluid3D([3751,3398,3805,3597],0); -ELEMENTS[73304] = Fluid3D([3751,3398,3597,3174],0); -ELEMENTS[73305] = Fluid3D([10336,10961,11509,11520],0); -ELEMENTS[73306] = Fluid3D([6516,5985,6689,5694],0); -ELEMENTS[73307] = Fluid3D([18112,18079,18092,18270],0); -ELEMENTS[73308] = Fluid3D([12123,12218,11257,10865],0); -ELEMENTS[73309] = Fluid3D([8054,7170,7407,7201],0); -ELEMENTS[73310] = Fluid3D([7407,8054,7201,7024],0); -ELEMENTS[73311] = Fluid3D([7201,7407,7024,6528],0); -ELEMENTS[73312] = Fluid3D([7024,7201,6528,7416],0); -ELEMENTS[73313] = Fluid3D([7201,7407,6528,7170],0); -ELEMENTS[73314] = Fluid3D([7024,7201,7416,8054],0); -ELEMENTS[73315] = Fluid3D([7201,7416,8054,7170],0); -ELEMENTS[73316] = Fluid3D([7201,7416,7170,6528],0); -ELEMENTS[73317] = Fluid3D([5452,6055,5801,5457],0); -ELEMENTS[73318] = Fluid3D([16704,16950,16619,16240],0); -ELEMENTS[73319] = Fluid3D([8739,8103,8154,8927],0); -ELEMENTS[73320] = Fluid3D([11827,11357,10536,10927],0); -ELEMENTS[73321] = Fluid3D([3386,3652,3768,4025],0); -ELEMENTS[73322] = Fluid3D([17712,17958,18102,17949],0); -ELEMENTS[73323] = Fluid3D([2283,2606,2261,2550],0); -ELEMENTS[73324] = Fluid3D([14243,13962,14683,14838],0); -ELEMENTS[73325] = Fluid3D([5216,5382,4657,5065],0); -ELEMENTS[73326] = Fluid3D([11762,11737,11481,12392],0); -ELEMENTS[73327] = Fluid3D([7614,7647,8615,8488],0); -ELEMENTS[73328] = Fluid3D([3135,3647,3437,3335],0); -ELEMENTS[73329] = Fluid3D([14142,14960,13842,14802],0); -ELEMENTS[73330] = Fluid3D([17334,17482,17290,16913],0); -ELEMENTS[73331] = Fluid3D([13297,12739,13807,13336],0); -ELEMENTS[73332] = Fluid3D([14610,14251,13612,13848],0); -ELEMENTS[73333] = Fluid3D([8076,7696,7079,7803],0); -ELEMENTS[73334] = Fluid3D([10363,11051,11316,10382],0); -ELEMENTS[73335] = Fluid3D([6286,5828,5864,6568],0); -ELEMENTS[73336] = Fluid3D([15208,14837,14873,15345],0); -ELEMENTS[73337] = Fluid3D([3080,3416,3669,3065],0); -ELEMENTS[73338] = Fluid3D([9538,8691,9692,9645],0); -ELEMENTS[73339] = Fluid3D([13435,13137,13930,14218],0); -ELEMENTS[73340] = Fluid3D([15014,15645,14486,14892],0); -ELEMENTS[73341] = Fluid3D([14486,15014,14892,14360],0); -ELEMENTS[73342] = Fluid3D([9971,9378,9847,10848],0); -ELEMENTS[73343] = Fluid3D([10504,11220,11488,11421],0); -ELEMENTS[73344] = Fluid3D([14481,14178,14760,13883],0); -ELEMENTS[73345] = Fluid3D([18553,18548,18412,18543],0); -ELEMENTS[73346] = Fluid3D([15139,15701,15639,16131],0); -ELEMENTS[73347] = Fluid3D([17165,17315,17003,16695],0); -ELEMENTS[73348] = Fluid3D([3604,3745,4103,4176],0); -ELEMENTS[73349] = Fluid3D([2001,2213,2086,2065],0); -ELEMENTS[73350] = Fluid3D([15676,15396,15156,15747],0); -ELEMENTS[73351] = Fluid3D([4445,4940,4757,4957],0); -ELEMENTS[73352] = Fluid3D([10848,11776,11238,11778],0); -ELEMENTS[73353] = Fluid3D([11238,10848,11778,11284],0); -ELEMENTS[73354] = Fluid3D([7841,6909,7035,7602],0); -ELEMENTS[73355] = Fluid3D([7841,6909,7602,7539],0); -ELEMENTS[73356] = Fluid3D([7602,7841,7539,8575],0); -ELEMENTS[73357] = Fluid3D([14296,15001,14072,14793],0); -ELEMENTS[73358] = Fluid3D([3482,3329,3050,3528],0); -ELEMENTS[73359] = Fluid3D([7298,7220,8308,8509],0); -ELEMENTS[73360] = Fluid3D([17926,17874,17623,18080],0); -ELEMENTS[73361] = Fluid3D([11716,10867,11707,12427],0); -ELEMENTS[73362] = Fluid3D([16578,16930,16463,16803],0); -ELEMENTS[73363] = Fluid3D([15072,15359,15668,15062],0); -ELEMENTS[73364] = Fluid3D([9920,10675,10139,10011],0); -ELEMENTS[73365] = Fluid3D([2257,2214,2032,2210],0); -ELEMENTS[73366] = Fluid3D([15796,15858,15954,16146],0); -ELEMENTS[73367] = Fluid3D([11069,10314,11249,10058],0); -ELEMENTS[73368] = Fluid3D([4772,4802,5218,4489],0); -ELEMENTS[73369] = Fluid3D([10604,11911,11438,11726],0); -ELEMENTS[73370] = Fluid3D([9206,10130,9985,9461],0); -ELEMENTS[73371] = Fluid3D([9485,8749,8473,8913],0); -ELEMENTS[73372] = Fluid3D([17704,17925,18004,17860],0); -ELEMENTS[73373] = Fluid3D([3777,3598,4030,3418],0); -ELEMENTS[73374] = Fluid3D([14486,13673,14086,13942],0); -ELEMENTS[73375] = Fluid3D([15279,15601,15266,15025],0); -ELEMENTS[73376] = Fluid3D([15279,15601,15025,15480],0); -ELEMENTS[73377] = Fluid3D([5710,6767,6363,6027],0); -ELEMENTS[73378] = Fluid3D([3631,4071,4205,3623],0); -ELEMENTS[73379] = Fluid3D([9945,10474,10638,11164],0); -ELEMENTS[73380] = Fluid3D([9945,10474,11164,10086],0); -ELEMENTS[73381] = Fluid3D([9945,10474,10086,8895],0); -ELEMENTS[73382] = Fluid3D([10474,11164,10086,10479],0); -ELEMENTS[73383] = Fluid3D([10086,10474,10479,9323],0); -ELEMENTS[73384] = Fluid3D([11164,10086,10479,9962],0); -ELEMENTS[73385] = Fluid3D([10086,10479,9962,8745],0); -ELEMENTS[73386] = Fluid3D([3546,3122,3313,3215],0); -ELEMENTS[73387] = Fluid3D([3546,3122,3215,3334],0); -ELEMENTS[73388] = Fluid3D([17783,17463,17916,17742],0); -ELEMENTS[73389] = Fluid3D([1812,1660,1681,1828],0); -ELEMENTS[73390] = Fluid3D([10514,10282,9614,9802],0); -ELEMENTS[73391] = Fluid3D([11447,11118,12227,11591],0); -ELEMENTS[73392] = Fluid3D([5674,5458,6134,5335],0); -ELEMENTS[73393] = Fluid3D([9242,9903,8537,8741],0); -ELEMENTS[73394] = Fluid3D([11377,11059,12222,11975],0); -ELEMENTS[73395] = Fluid3D([6050,7078,6563,5843],0); -ELEMENTS[73396] = Fluid3D([14355,13773,13766,13959],0); -ELEMENTS[73397] = Fluid3D([16907,16455,16566,15987],0); -ELEMENTS[73398] = Fluid3D([14866,15341,14454,14916],0); -ELEMENTS[73399] = Fluid3D([14866,15341,14916,15616],0); -ELEMENTS[73400] = Fluid3D([17356,17514,17665,17871],0); -ELEMENTS[73401] = Fluid3D([13898,13145,12738,13858],0); -ELEMENTS[73402] = Fluid3D([11703,11581,12641,12760],0); -ELEMENTS[73403] = Fluid3D([8035,7148,7589,7147],0); -ELEMENTS[73404] = Fluid3D([18502,18470,18374,18589],0); -ELEMENTS[73405] = Fluid3D([16649,16190,16422,16864],0); -ELEMENTS[73406] = Fluid3D([8345,7790,8121,8707],0); -ELEMENTS[73407] = Fluid3D([8345,7790,8707,8686],0); -ELEMENTS[73408] = Fluid3D([7790,8707,8686,8916],0); -ELEMENTS[73409] = Fluid3D([8707,8686,8916,9477],0); -ELEMENTS[73410] = Fluid3D([7790,8707,8916,8121],0); -ELEMENTS[73411] = Fluid3D([8707,8916,8121,8925],0); -ELEMENTS[73412] = Fluid3D([8707,8916,8925,9397],0); -ELEMENTS[73413] = Fluid3D([8707,8916,9397,9477],0); -ELEMENTS[73414] = Fluid3D([9397,8707,9477,8345],0); -ELEMENTS[73415] = Fluid3D([8707,8686,9477,8345],0); -ELEMENTS[73416] = Fluid3D([8121,8707,8925,8345],0); -ELEMENTS[73417] = Fluid3D([8925,8707,9397,8345],0); -ELEMENTS[73418] = Fluid3D([8916,9397,9477,9478],0); -ELEMENTS[73419] = Fluid3D([8916,9397,9478,10255],0); -ELEMENTS[73420] = Fluid3D([9397,9477,9478,10255],0); -ELEMENTS[73421] = Fluid3D([8916,9397,10255,9913],0); -ELEMENTS[73422] = Fluid3D([9397,10255,9913,9477],0); -ELEMENTS[73423] = Fluid3D([9913,9397,9477,9396],0); -ELEMENTS[73424] = Fluid3D([9913,9397,9396,8925],0); -ELEMENTS[73425] = Fluid3D([9913,9397,8925,8916],0); -ELEMENTS[73426] = Fluid3D([9397,9477,9396,8971],0); -ELEMENTS[73427] = Fluid3D([9396,9397,8971,8925],0); -ELEMENTS[73428] = Fluid3D([9477,9396,8971,8345],0); -ELEMENTS[73429] = Fluid3D([9396,8971,8345,8375],0); -ELEMENTS[73430] = Fluid3D([8971,8345,8375,8925],0); -ELEMENTS[73431] = Fluid3D([9396,8971,8375,8925],0); -ELEMENTS[73432] = Fluid3D([8971,9477,8345,9397],0); -ELEMENTS[73433] = Fluid3D([8971,8345,8925,9397],0); -ELEMENTS[73434] = Fluid3D([5076,5582,5690,5112],0); -ELEMENTS[73435] = Fluid3D([7979,7497,8347,8877],0); -ELEMENTS[73436] = Fluid3D([11397,11433,10467,10818],0); -ELEMENTS[73437] = Fluid3D([17828,17633,17648,18068],0); -ELEMENTS[73438] = Fluid3D([5175,5284,4896,4566],0); -ELEMENTS[73439] = Fluid3D([11706,11930,10958,12069],0); -ELEMENTS[73440] = Fluid3D([16513,15856,15842,16000],0); -ELEMENTS[73441] = Fluid3D([11439,12387,12379,12405],0); -ELEMENTS[73442] = Fluid3D([3814,3402,3810,3618],0); -ELEMENTS[73443] = Fluid3D([11763,11994,12680,11993],0); -ELEMENTS[73444] = Fluid3D([8068,8507,7745,7181],0); -ELEMENTS[73445] = Fluid3D([15541,15977,15545,16122],0); -ELEMENTS[73446] = Fluid3D([3335,3526,3183,3594],0); -ELEMENTS[73447] = Fluid3D([13052,12062,13161,12612],0); -ELEMENTS[73448] = Fluid3D([4638,4832,4153,4753],0); -ELEMENTS[73449] = Fluid3D([7768,7257,7123,8027],0); -ELEMENTS[73450] = Fluid3D([2823,2770,2598,2555],0); -ELEMENTS[73451] = Fluid3D([2823,2770,2555,2713],0); -ELEMENTS[73452] = Fluid3D([2770,2555,2713,2943],0); -ELEMENTS[73453] = Fluid3D([11508,11883,12291,11968],0); -ELEMENTS[73454] = Fluid3D([16311,16652,17036,16892],0); -ELEMENTS[73455] = Fluid3D([16652,17036,16892,17096],0); -ELEMENTS[73456] = Fluid3D([1809,1873,1698,1915],0); -ELEMENTS[73457] = Fluid3D([10317,10587,9619,11022],0); -ELEMENTS[73458] = Fluid3D([6110,5976,5400,5319],0); -ELEMENTS[73459] = Fluid3D([5400,6110,5319,5671],0); -ELEMENTS[73460] = Fluid3D([6664,5985,6718,6689],0); -ELEMENTS[73461] = Fluid3D([6898,6988,6479,7733],0); -ELEMENTS[73462] = Fluid3D([5107,5483,4953,4710],0); -ELEMENTS[73463] = Fluid3D([12080,12678,12802,13302],0); -ELEMENTS[73464] = Fluid3D([16590,16449,15849,16088],0); -ELEMENTS[73465] = Fluid3D([15085,15308,15976,15802],0); -ELEMENTS[73466] = Fluid3D([8074,7823,8886,8576],0); -ELEMENTS[73467] = Fluid3D([4799,4717,4258,4738],0); -ELEMENTS[73468] = Fluid3D([8903,8969,9955,9402],0); -ELEMENTS[73469] = Fluid3D([7036,7676,7252,7969],0); -ELEMENTS[73470] = Fluid3D([7036,7676,7969,7396],0); -ELEMENTS[73471] = Fluid3D([5832,5288,5222,5964],0); -ELEMENTS[73472] = Fluid3D([4232,3856,4424,4267],0); -ELEMENTS[73473] = Fluid3D([17334,17033,16913,17290],0); -ELEMENTS[73474] = Fluid3D([13075,13310,12578,12041],0); -ELEMENTS[73475] = Fluid3D([15392,15332,16048,15785],0); -ELEMENTS[73476] = Fluid3D([11676,11718,10772,11004],0); -ELEMENTS[73477] = Fluid3D([15736,15737,16278,16255],0); -ELEMENTS[73478] = Fluid3D([18016,18233,18337,18191],0); -ELEMENTS[73479] = Fluid3D([4061,4135,4217,3596],0); -ELEMENTS[73480] = Fluid3D([13961,14479,13858,13993],0); -ELEMENTS[73481] = Fluid3D([10027,9513,10520,10867],0); -ELEMENTS[73482] = Fluid3D([16697,17155,16750,16719],0); -ELEMENTS[73483] = Fluid3D([18500,18581,18499,18423],0); -ELEMENTS[73484] = Fluid3D([13964,13261,13140,13001],0); -ELEMENTS[73485] = Fluid3D([17121,16798,16979,16601],0); -ELEMENTS[73486] = Fluid3D([17121,16798,16601,17145],0); -ELEMENTS[73487] = Fluid3D([16516,16121,15994,15748],0); -ELEMENTS[73488] = Fluid3D([15097,14849,15353,14555],0); -ELEMENTS[73489] = Fluid3D([12704,12555,13402,13758],0); -ELEMENTS[73490] = Fluid3D([15883,16269,15609,15716],0); -ELEMENTS[73491] = Fluid3D([15582,15509,16174,16306],0); -ELEMENTS[73492] = Fluid3D([12987,12986,12382,11692],0); -ELEMENTS[73493] = Fluid3D([2872,3129,2687,2928],0); -ELEMENTS[73494] = Fluid3D([2186,2288,2094,1964],0); -ELEMENTS[73495] = Fluid3D([8075,7593,7731,7015],0); -ELEMENTS[73496] = Fluid3D([11082,10705,10776,9899],0); -ELEMENTS[73497] = Fluid3D([3593,3853,3919,3862],0); -ELEMENTS[73498] = Fluid3D([3853,3919,3862,4441],0); -ELEMENTS[73499] = Fluid3D([3593,3853,3862,3460],0); -ELEMENTS[73500] = Fluid3D([11382,11452,10781,10051],0); -ELEMENTS[73501] = Fluid3D([18017,17919,18193,18291],0); -ELEMENTS[73502] = Fluid3D([11483,12085,12496,11710],0); -ELEMENTS[73503] = Fluid3D([12815,13642,13461,13982],0); -ELEMENTS[73504] = Fluid3D([12044,11849,11587,10581],0); -ELEMENTS[73505] = Fluid3D([12836,13175,12323,13445],0); -ELEMENTS[73506] = Fluid3D([18539,18605,18540,18416],0); -ELEMENTS[73507] = Fluid3D([16192,16016,16459,16082],0); -ELEMENTS[73508] = Fluid3D([16459,16192,16082,16836],0); -ELEMENTS[73509] = Fluid3D([16192,16016,16082,15455],0); -ELEMENTS[73510] = Fluid3D([16459,16192,16836,16504],0); -ELEMENTS[73511] = Fluid3D([13362,13902,14121,14605],0); -ELEMENTS[73512] = Fluid3D([6349,7132,6352,5822],0); -ELEMENTS[73513] = Fluid3D([7026,7263,6399,6407],0); -ELEMENTS[73514] = Fluid3D([16999,16506,16944,16522],0); -ELEMENTS[73515] = Fluid3D([12658,12880,13741,12756],0); -ELEMENTS[73516] = Fluid3D([16716,16553,16124,16477],0); -ELEMENTS[73517] = Fluid3D([5663,6346,6233,5421],0); -ELEMENTS[73518] = Fluid3D([8852,9024,8098,8194],0); -ELEMENTS[73519] = Fluid3D([8670,8524,8387,7514],0); -ELEMENTS[73520] = Fluid3D([13688,13306,13403,12606],0); -ELEMENTS[73521] = Fluid3D([16099,16614,16852,16607],0); -ELEMENTS[73522] = Fluid3D([18103,18278,18302,18247],0); -ELEMENTS[73523] = Fluid3D([18103,18278,18247,17877],0); -ELEMENTS[73524] = Fluid3D([10858,10282,9918,9614],0); -ELEMENTS[73525] = Fluid3D([10307,9800,10058,9103],0); -ELEMENTS[73526] = Fluid3D([17896,18137,17770,18059],0); -ELEMENTS[73527] = Fluid3D([17896,18137,18059,18221],0); -ELEMENTS[73528] = Fluid3D([12223,11766,11686,10912],0); -ELEMENTS[73529] = Fluid3D([16194,15816,16010,16300],0); -ELEMENTS[73530] = Fluid3D([8612,7979,8350,8333],0); -ELEMENTS[73531] = Fluid3D([8470,7723,7929,7235],0); -ELEMENTS[73532] = Fluid3D([13280,12380,13367,13023],0); -ELEMENTS[73533] = Fluid3D([2946,2739,3179,3123],0); -ELEMENTS[73534] = Fluid3D([16732,16948,16372,16389],0); -ELEMENTS[73535] = Fluid3D([18002,17906,17785,18118],0); -ELEMENTS[73536] = Fluid3D([8025,8293,8484,7663],0); -ELEMENTS[73537] = Fluid3D([12330,11232,11046,12239],0); -ELEMENTS[73538] = Fluid3D([15654,15239,15676,16154],0); -ELEMENTS[73539] = Fluid3D([15584,14936,15512,15623],0); -ELEMENTS[73540] = Fluid3D([10005,11034,11444,10764],0); -ELEMENTS[73541] = Fluid3D([11280,10358,10181,10447],0); -ELEMENTS[73542] = Fluid3D([13989,13545,13366,13775],0); -ELEMENTS[73543] = Fluid3D([11087,12038,11777,12120],0); -ELEMENTS[73544] = Fluid3D([16486,15933,16362,16499],0); -ELEMENTS[73545] = Fluid3D([12047,12674,12246,13219],0); -ELEMENTS[73546] = Fluid3D([6608,6093,6294,6073],0); -ELEMENTS[73547] = Fluid3D([18528,18504,18571,18620],0); -ELEMENTS[73548] = Fluid3D([11275,11033,10465,11272],0); -ELEMENTS[73549] = Fluid3D([1660,1575,1659,1727],0); -ELEMENTS[73550] = Fluid3D([15742,15713,15690,16463],0); -ELEMENTS[73551] = Fluid3D([16972,16576,17136,16836],0); -ELEMENTS[73552] = Fluid3D([7298,7583,7076,8509],0); -ELEMENTS[73553] = Fluid3D([16663,16878,16555,16152],0); -ELEMENTS[73554] = Fluid3D([7597,6893,7713,8220],0); -ELEMENTS[73555] = Fluid3D([7163,6414,6886,7097],0); -ELEMENTS[73556] = Fluid3D([6414,6886,7097,6558],0); -ELEMENTS[73557] = Fluid3D([7163,6414,7097,7385],0); -ELEMENTS[73558] = Fluid3D([6518,7118,6208,6058],0); -ELEMENTS[73559] = Fluid3D([15847,15387,15517,15473],0); -ELEMENTS[73560] = Fluid3D([15847,15387,15473,15163],0); -ELEMENTS[73561] = Fluid3D([16549,16694,16120,16265],0); -ELEMENTS[73562] = Fluid3D([3974,3977,3868,4425],0); -ELEMENTS[73563] = Fluid3D([1713,1785,1786,1916],0); -ELEMENTS[73564] = Fluid3D([14188,14969,14944,14700],0); -ELEMENTS[73565] = Fluid3D([14969,14944,14700,15643],0); -ELEMENTS[73566] = Fluid3D([14188,14969,14700,14892],0); -ELEMENTS[73567] = Fluid3D([14700,14188,14892,14253],0); -ELEMENTS[73568] = Fluid3D([14700,14188,14253,14944],0); -ELEMENTS[73569] = Fluid3D([14253,14700,14944,14772],0); -ELEMENTS[73570] = Fluid3D([14253,14700,14772,15298],0); -ELEMENTS[73571] = Fluid3D([14253,14700,15298,14892],0); -ELEMENTS[73572] = Fluid3D([14700,14944,14772,15643],0); -ELEMENTS[73573] = Fluid3D([14944,14253,14772,13954],0); -ELEMENTS[73574] = Fluid3D([17853,17595,17658,17378],0); -ELEMENTS[73575] = Fluid3D([5855,6132,6446,6660],0); -ELEMENTS[73576] = Fluid3D([5097,5508,5506,5535],0); -ELEMENTS[73577] = Fluid3D([5097,5508,5535,5099],0); -ELEMENTS[73578] = Fluid3D([5097,5508,5099,5009],0); -ELEMENTS[73579] = Fluid3D([5097,5508,5009,4727],0); -ELEMENTS[73580] = Fluid3D([5097,5508,4727,4994],0); -ELEMENTS[73581] = Fluid3D([8348,7970,8634,7776],0); -ELEMENTS[73582] = Fluid3D([9786,9383,8646,8614],0); -ELEMENTS[73583] = Fluid3D([10155,10221,11172,10497],0); -ELEMENTS[73584] = Fluid3D([17579,17633,17713,17307],0); -ELEMENTS[73585] = Fluid3D([17633,17713,17307,17682],0); -ELEMENTS[73586] = Fluid3D([17713,17307,17682,17226],0); -ELEMENTS[73587] = Fluid3D([17713,17307,17226,17579],0); -ELEMENTS[73588] = Fluid3D([16457,16034,16651,16478],0); -ELEMENTS[73589] = Fluid3D([9510,9985,9560,9962],0); -ELEMENTS[73590] = Fluid3D([4910,4963,4719,5613],0); -ELEMENTS[73591] = Fluid3D([12962,12112,12255,11946],0); -ELEMENTS[73592] = Fluid3D([17064,16869,17266,16500],0); -ELEMENTS[73593] = Fluid3D([17064,16869,16500,16858],0); -ELEMENTS[73594] = Fluid3D([14306,13902,13683,13470],0); -ELEMENTS[73595] = Fluid3D([7692,6751,7062,6457],0); -ELEMENTS[73596] = Fluid3D([7921,7291,7420,6669],0); -ELEMENTS[73597] = Fluid3D([15449,15895,15472,15183],0); -ELEMENTS[73598] = Fluid3D([16463,16339,15713,15690],0); -ELEMENTS[73599] = Fluid3D([5143,5943,5419,5556],0); -ELEMENTS[73600] = Fluid3D([2605,2888,2883,3066],0); -ELEMENTS[73601] = Fluid3D([4162,4487,3980,4248],0); -ELEMENTS[73602] = Fluid3D([3506,3641,3320,3138],0); -ELEMENTS[73603] = Fluid3D([12793,12133,12976,13279],0); -ELEMENTS[73604] = Fluid3D([10287,10813,11317,11373],0); -ELEMENTS[73605] = Fluid3D([10813,11317,11373,11241],0); -ELEMENTS[73606] = Fluid3D([4829,5090,4731,5335],0); -ELEMENTS[73607] = Fluid3D([16916,16687,17043,17129],0); -ELEMENTS[73608] = Fluid3D([9532,9781,8552,9464],0); -ELEMENTS[73609] = Fluid3D([9532,9781,9464,9852],0); -ELEMENTS[73610] = Fluid3D([1913,1804,1879,2086],0); -ELEMENTS[73611] = Fluid3D([12793,12178,13158,12195],0); -ELEMENTS[73612] = Fluid3D([2493,2248,2233,2182],0); -ELEMENTS[73613] = Fluid3D([1875,1880,2098,2087],0); -ELEMENTS[73614] = Fluid3D([11849,11307,11781,10869],0); -ELEMENTS[73615] = Fluid3D([11849,11307,10869,10581],0); -ELEMENTS[73616] = Fluid3D([12933,13196,12040,12390],0); -ELEMENTS[73617] = Fluid3D([12040,12933,12390,11560],0); -ELEMENTS[73618] = Fluid3D([11469,11827,10536,10642],0); -ELEMENTS[73619] = Fluid3D([17008,16528,16837,16968],0); -ELEMENTS[73620] = Fluid3D([13768,13434,13572,14119],0); -ELEMENTS[73621] = Fluid3D([5822,6286,6697,7132],0); -ELEMENTS[73622] = Fluid3D([11631,11726,12082,12894],0); -ELEMENTS[73623] = Fluid3D([10988,11753,12265,11294],0); -ELEMENTS[73624] = Fluid3D([10221,10560,11308,10539],0); -ELEMENTS[73625] = Fluid3D([9427,10149,10284,9556],0); -ELEMENTS[73626] = Fluid3D([7186,7268,6311,6542],0); -ELEMENTS[73627] = Fluid3D([3440,3313,3009,3221],0); -ELEMENTS[73628] = Fluid3D([1739,1677,1740,1870],0); -ELEMENTS[73629] = Fluid3D([3523,3930,3959,4292],0); -ELEMENTS[73630] = Fluid3D([12911,12182,12664,13532],0); -ELEMENTS[73631] = Fluid3D([12227,12714,11447,12014],0); -ELEMENTS[73632] = Fluid3D([8192,8437,8752,7603],0); -ELEMENTS[73633] = Fluid3D([18039,18182,18300,18255],0); -ELEMENTS[73634] = Fluid3D([14850,14749,15346,15054],0); -ELEMENTS[73635] = Fluid3D([7129,6513,6365,6563],0); -ELEMENTS[73636] = Fluid3D([13572,12718,13768,13471],0); -ELEMENTS[73637] = Fluid3D([15523,15877,15716,15321],0); -ELEMENTS[73638] = Fluid3D([15877,15716,15321,15927],0); -ELEMENTS[73639] = Fluid3D([11312,12052,12487,11269],0); -ELEMENTS[73640] = Fluid3D([12052,12487,11269,12170],0); -ELEMENTS[73641] = Fluid3D([13142,12665,13309,12167],0); -ELEMENTS[73642] = Fluid3D([2849,2602,2647,2800],0); -ELEMENTS[73643] = Fluid3D([14953,15416,15805,15632],0); -ELEMENTS[73644] = Fluid3D([11432,10848,11776,10894],0); -ELEMENTS[73645] = Fluid3D([15644,15563,16066,16207],0); -ELEMENTS[73646] = Fluid3D([9350,10273,10400,10115],0); -ELEMENTS[73647] = Fluid3D([5094,5283,4531,4775],0); -ELEMENTS[73648] = Fluid3D([18621,18559,18558,18486],0); -ELEMENTS[73649] = Fluid3D([13913,13017,13174,12929],0); -ELEMENTS[73650] = Fluid3D([17838,17714,18092,18037],0); -ELEMENTS[73651] = Fluid3D([8790,7970,8785,8590],0); -ELEMENTS[73652] = Fluid3D([11993,12098,12983,12680],0); -ELEMENTS[73653] = Fluid3D([10638,11286,11820,11978],0); -ELEMENTS[73654] = Fluid3D([11369,12194,12463,12401],0); -ELEMENTS[73655] = Fluid3D([10389,10245,10937,11349],0); -ELEMENTS[73656] = Fluid3D([8620,8132,8820,7629],0); -ELEMENTS[73657] = Fluid3D([15690,16183,16463,16339],0); -ELEMENTS[73658] = Fluid3D([10529,9477,10104,9396],0); -ELEMENTS[73659] = Fluid3D([10529,9477,9396,9913],0); -ELEMENTS[73660] = Fluid3D([4048,4293,4142,4606],0); -ELEMENTS[73661] = Fluid3D([4048,4293,4606,4946],0); -ELEMENTS[73662] = Fluid3D([9143,9855,10118,9962],0); -ELEMENTS[73663] = Fluid3D([10209,10605,10216,9290],0); -ELEMENTS[73664] = Fluid3D([12094,11753,10822,11294],0); -ELEMENTS[73665] = Fluid3D([14257,13291,13547,13390],0); -ELEMENTS[73666] = Fluid3D([8326,7409,7363,8204],0); -ELEMENTS[73667] = Fluid3D([4092,4029,3656,4306],0); -ELEMENTS[73668] = Fluid3D([7148,6368,7147,6918],0); -ELEMENTS[73669] = Fluid3D([4378,4070,4300,4450],0); -ELEMENTS[73670] = Fluid3D([5088,5449,4673,5409],0); -ELEMENTS[73671] = Fluid3D([7844,7418,7634,8323],0); -ELEMENTS[73672] = Fluid3D([7634,7844,8323,7818],0); -ELEMENTS[73673] = Fluid3D([3820,3743,4184,3878],0); -ELEMENTS[73674] = Fluid3D([14608,15046,15065,15535],0); -ELEMENTS[73675] = Fluid3D([8335,8203,7357,7305],0); -ELEMENTS[73676] = Fluid3D([8335,8203,7305,8145],0); -ELEMENTS[73677] = Fluid3D([14933,14525,14854,15035],0); -ELEMENTS[73678] = Fluid3D([12511,11921,13073,13242],0); -ELEMENTS[73679] = Fluid3D([10378,10612,9408,9330],0); -ELEMENTS[73680] = Fluid3D([5606,5848,6091,6199],0); -ELEMENTS[73681] = Fluid3D([6091,5606,6199,6536],0); -ELEMENTS[73682] = Fluid3D([6199,6091,6536,7050],0); -ELEMENTS[73683] = Fluid3D([6536,6199,7050,6061],0); -ELEMENTS[73684] = Fluid3D([6536,6199,6061,5606],0); -ELEMENTS[73685] = Fluid3D([6199,6061,5606,5848],0); -ELEMENTS[73686] = Fluid3D([6199,7050,6061,6555],0); -ELEMENTS[73687] = Fluid3D([6199,7050,6555,6091],0); -ELEMENTS[73688] = Fluid3D([6061,6199,6555,5848],0); -ELEMENTS[73689] = Fluid3D([6199,6555,5848,6091],0); -ELEMENTS[73690] = Fluid3D([4722,5109,4793,4693],0); -ELEMENTS[73691] = Fluid3D([3574,3607,3907,3851],0); -ELEMENTS[73692] = Fluid3D([15083,14493,15539,15160],0); -ELEMENTS[73693] = Fluid3D([6928,7756,7772,7990],0); -ELEMENTS[73694] = Fluid3D([15752,16090,15656,16049],0); -ELEMENTS[73695] = Fluid3D([12784,12993,13844,13462],0); -ELEMENTS[73696] = Fluid3D([8213,8339,9237,8955],0); -ELEMENTS[73697] = Fluid3D([6093,5650,5439,5758],0); -ELEMENTS[73698] = Fluid3D([15076,14821,15580,15143],0); -ELEMENTS[73699] = Fluid3D([14821,15580,15143,14942],0); -ELEMENTS[73700] = Fluid3D([12387,11439,11992,12405],0); -ELEMENTS[73701] = Fluid3D([11039,11346,10869,11849],0); -ELEMENTS[73702] = Fluid3D([5315,4778,5195,5099],0); -ELEMENTS[73703] = Fluid3D([16083,15885,15404,15239],0); -ELEMENTS[73704] = Fluid3D([15013,14667,14839,15574],0); -ELEMENTS[73705] = Fluid3D([15013,14667,15574,14753],0); -ELEMENTS[73706] = Fluid3D([9590,9419,8492,8840],0); -ELEMENTS[73707] = Fluid3D([13482,12549,12884,13525],0); -ELEMENTS[73708] = Fluid3D([13482,12549,13525,12704],0); -ELEMENTS[73709] = Fluid3D([12916,13017,13950,13706],0); -ELEMENTS[73710] = Fluid3D([18476,18488,18499,18346],0); -ELEMENTS[73711] = Fluid3D([14921,14727,15355,15793],0); -ELEMENTS[73712] = Fluid3D([9206,8567,8976,9107],0); -ELEMENTS[73713] = Fluid3D([18451,18532,18503,18498],0); -ELEMENTS[73714] = Fluid3D([10769,10414,10777,9931],0); -ELEMENTS[73715] = Fluid3D([17020,16541,16868,16820],0); -ELEMENTS[73716] = Fluid3D([7723,8533,7907,7340],0); -ELEMENTS[73717] = Fluid3D([17884,17534,17664,17441],0); -ELEMENTS[73718] = Fluid3D([12433,13150,12457,12498],0); -ELEMENTS[73719] = Fluid3D([13746,12787,13733,12976],0); -ELEMENTS[73720] = Fluid3D([13746,12787,12976,12688],0); -ELEMENTS[73721] = Fluid3D([1722,1795,1693,1932],0); -ELEMENTS[73722] = Fluid3D([6428,5995,7135,6898],0); -ELEMENTS[73723] = Fluid3D([12875,12148,11746,12044],0); -ELEMENTS[73724] = Fluid3D([2781,2988,3239,2825],0); -ELEMENTS[73725] = Fluid3D([18297,18206,18452,18412],0); -ELEMENTS[73726] = Fluid3D([16607,16402,15843,15746],0); -ELEMENTS[73727] = Fluid3D([4990,5317,5121,4641],0); -ELEMENTS[73728] = Fluid3D([17191,17084,17525,17442],0); -ELEMENTS[73729] = Fluid3D([18522,18533,18417,18524],0); -ELEMENTS[73730] = Fluid3D([5266,5530,5993,5118],0); -ELEMENTS[73731] = Fluid3D([5266,5530,5118,4850],0); -ELEMENTS[73732] = Fluid3D([4094,4286,3955,3643],0); -ELEMENTS[73733] = Fluid3D([6696,6744,6709,7355],0); -ELEMENTS[73734] = Fluid3D([10791,9837,10940,10157],0); -ELEMENTS[73735] = Fluid3D([2823,2713,3052,2770],0); -ELEMENTS[73736] = Fluid3D([16380,16322,16752,16818],0); -ELEMENTS[73737] = Fluid3D([16380,16322,16818,16363],0); -ELEMENTS[73738] = Fluid3D([3935,3520,3878,3743],0); -ELEMENTS[73739] = Fluid3D([4577,4977,4955,5139],0); -ELEMENTS[73740] = Fluid3D([11220,10658,11225,11972],0); -ELEMENTS[73741] = Fluid3D([10343,11272,11033,10946],0); -ELEMENTS[73742] = Fluid3D([3776,3526,3312,3362],0); -ELEMENTS[73743] = Fluid3D([3526,3312,3362,2969],0); -ELEMENTS[73744] = Fluid3D([14528,14539,15164,14540],0); -ELEMENTS[73745] = Fluid3D([4150,4693,4220,4272],0); -ELEMENTS[73746] = Fluid3D([10087,9928,9029,9476],0); -ELEMENTS[73747] = Fluid3D([13020,14028,13750,13360],0); -ELEMENTS[73748] = Fluid3D([10270,10330,9393,9653],0); -ELEMENTS[73749] = Fluid3D([13243,12754,12812,12253],0); -ELEMENTS[73750] = Fluid3D([12812,13243,12253,12303],0); -ELEMENTS[73751] = Fluid3D([12253,12812,12303,11545],0); -ELEMENTS[73752] = Fluid3D([12754,12812,12253,11545],0); -ELEMENTS[73753] = Fluid3D([17946,18075,17863,18149],0); -ELEMENTS[73754] = Fluid3D([10215,10896,11115,10776],0); -ELEMENTS[73755] = Fluid3D([7022,7258,6387,6987],0); -ELEMENTS[73756] = Fluid3D([5537,5731,5223,5295],0); -ELEMENTS[73757] = Fluid3D([15438,15754,15649,15186],0); -ELEMENTS[73758] = Fluid3D([15754,15649,15186,15532],0); -ELEMENTS[73759] = Fluid3D([15754,15649,15532,15876],0); -ELEMENTS[73760] = Fluid3D([15186,15754,15532,15760],0); -ELEMENTS[73761] = Fluid3D([15754,15532,15760,15876],0); -ELEMENTS[73762] = Fluid3D([15532,15760,15876,14969],0); -ELEMENTS[73763] = Fluid3D([15532,15760,14969,15186],0); -ELEMENTS[73764] = Fluid3D([15876,15532,14969,15643],0); -ELEMENTS[73765] = Fluid3D([14969,15532,15186,15649],0); -ELEMENTS[73766] = Fluid3D([14969,15532,15649,15643],0); -ELEMENTS[73767] = Fluid3D([15532,15649,15643,15876],0); -ELEMENTS[73768] = Fluid3D([15747,16258,16374,15654],0); -ELEMENTS[73769] = Fluid3D([16374,15747,15654,16158],0); -ELEMENTS[73770] = Fluid3D([14974,15036,14132,14630],0); -ELEMENTS[73771] = Fluid3D([14974,15036,14630,15674],0); -ELEMENTS[73772] = Fluid3D([12669,11849,11781,11927],0); -ELEMENTS[73773] = Fluid3D([7030,7583,7076,6993],0); -ELEMENTS[73774] = Fluid3D([10520,10001,10116,9481],0); -ELEMENTS[73775] = Fluid3D([17893,18084,17894,18076],0); -ELEMENTS[73776] = Fluid3D([18084,17894,18076,18193],0); -ELEMENTS[73777] = Fluid3D([17893,18084,18076,18118],0); -ELEMENTS[73778] = Fluid3D([18076,17893,18118,17785],0); -ELEMENTS[73779] = Fluid3D([18076,17893,17785,17894],0); -ELEMENTS[73780] = Fluid3D([17785,18076,17894,18193],0); -ELEMENTS[73781] = Fluid3D([17785,18076,18193,18002],0); -ELEMENTS[73782] = Fluid3D([18076,18193,18002,18118],0); -ELEMENTS[73783] = Fluid3D([17785,18076,18002,18118],0); -ELEMENTS[73784] = Fluid3D([18076,18084,18193,18272],0); -ELEMENTS[73785] = Fluid3D([18193,18076,18272,18118],0); -ELEMENTS[73786] = Fluid3D([18076,18084,18272,18118],0); -ELEMENTS[73787] = Fluid3D([17401,17251,17045,16805],0); -ELEMENTS[73788] = Fluid3D([12196,12958,12519,13244],0); -ELEMENTS[73789] = Fluid3D([12196,12958,13244,13210],0); -ELEMENTS[73790] = Fluid3D([12958,13244,13210,14194],0); -ELEMENTS[73791] = Fluid3D([7648,7908,8132,9117],0); -ELEMENTS[73792] = Fluid3D([11772,12949,11613,13049],0); -ELEMENTS[73793] = Fluid3D([6741,7487,7704,7888],0); -ELEMENTS[73794] = Fluid3D([17255,17216,17623,17241],0); -ELEMENTS[73795] = Fluid3D([17255,17216,17241,16954],0); -ELEMENTS[73796] = Fluid3D([4482,5129,4569,4392],0); -ELEMENTS[73797] = Fluid3D([13629,13089,12705,12847],0); -ELEMENTS[73798] = Fluid3D([16348,16139,15667,15974],0); -ELEMENTS[73799] = Fluid3D([8478,8608,7652,7889],0); -ELEMENTS[73800] = Fluid3D([8478,8608,7889,8997],0); -ELEMENTS[73801] = Fluid3D([8608,7889,8997,8648],0); -ELEMENTS[73802] = Fluid3D([16574,17040,17038,16446],0); -ELEMENTS[73803] = Fluid3D([4899,5005,5489,5038],0); -ELEMENTS[73804] = Fluid3D([14874,15116,15800,15320],0); -ELEMENTS[73805] = Fluid3D([15991,15629,16303,16057],0); -ELEMENTS[73806] = Fluid3D([15991,15629,16057,15794],0); -ELEMENTS[73807] = Fluid3D([16057,15991,15794,16481],0); -ELEMENTS[73808] = Fluid3D([16282,16107,16522,15925],0); -ELEMENTS[73809] = Fluid3D([6862,6799,7572,6984],0); -ELEMENTS[73810] = Fluid3D([14102,13891,14943,14468],0); -ELEMENTS[73811] = Fluid3D([4688,5115,4722,4363],0); -ELEMENTS[73812] = Fluid3D([16046,15914,15638,16377],0); -ELEMENTS[73813] = Fluid3D([16784,16885,17112,16962],0); -ELEMENTS[73814] = Fluid3D([12699,11972,12218,11306],0); -ELEMENTS[73815] = Fluid3D([10362,10923,10845,9991],0); -ELEMENTS[73816] = Fluid3D([10362,10923,9991,9832],0); -ELEMENTS[73817] = Fluid3D([10923,10845,9991,9780],0); -ELEMENTS[73818] = Fluid3D([9991,10923,9780,9832],0); -ELEMENTS[73819] = Fluid3D([10845,9991,9780,9710],0); -ELEMENTS[73820] = Fluid3D([9991,9780,9710,9377],0); -ELEMENTS[73821] = Fluid3D([9991,9780,9377,9832],0); -ELEMENTS[73822] = Fluid3D([9377,9991,9832,10362],0); -ELEMENTS[73823] = Fluid3D([9377,9991,10362,9710],0); -ELEMENTS[73824] = Fluid3D([9832,9377,10362,10494],0); -ELEMENTS[73825] = Fluid3D([10845,9991,9710,10362],0); -ELEMENTS[73826] = Fluid3D([8834,8418,8771,9687],0); -ELEMENTS[73827] = Fluid3D([9929,11019,10870,10894],0); -ELEMENTS[73828] = Fluid3D([9679,9376,9507,10490],0); -ELEMENTS[73829] = Fluid3D([4845,5352,5382,5390],0); -ELEMENTS[73830] = Fluid3D([9487,10028,9104,9029],0); -ELEMENTS[73831] = Fluid3D([16948,16966,17072,16389],0); -ELEMENTS[73832] = Fluid3D([2065,2270,2173,2213],0); -ELEMENTS[73833] = Fluid3D([14409,13454,13912,14460],0); -ELEMENTS[73834] = Fluid3D([5282,5068,5522,5433],0); -ELEMENTS[73835] = Fluid3D([14741,15378,14891,14495],0); -ELEMENTS[73836] = Fluid3D([5109,5298,4793,5258],0); -ELEMENTS[73837] = Fluid3D([12961,12644,11710,12307],0); -ELEMENTS[73838] = Fluid3D([11710,12961,12307,12085],0); -ELEMENTS[73839] = Fluid3D([12461,11960,11402,10795],0); -ELEMENTS[73840] = Fluid3D([5386,6007,5516,5857],0); -ELEMENTS[73841] = Fluid3D([5386,6007,5857,5594],0); -ELEMENTS[73842] = Fluid3D([11117,10978,10357,11582],0); -ELEMENTS[73843] = Fluid3D([8574,9589,8916,8615],0); -ELEMENTS[73844] = Fluid3D([2936,3213,3383,3204],0); -ELEMENTS[73845] = Fluid3D([14707,15011,15632,15343],0); -ELEMENTS[73846] = Fluid3D([4799,4230,4389,4738],0); -ELEMENTS[73847] = Fluid3D([9619,9257,10414,10587],0); -ELEMENTS[73848] = Fluid3D([12000,11973,11928,10810],0); -ELEMENTS[73849] = Fluid3D([1659,1807,1828,1752],0); -ELEMENTS[73850] = Fluid3D([12738,12894,13858,12503],0); -ELEMENTS[73851] = Fluid3D([12738,12894,12503,11726],0); -ELEMENTS[73852] = Fluid3D([18623,18585,18608,18632],0); -ELEMENTS[73853] = Fluid3D([14859,14847,15428,15719],0); -ELEMENTS[73854] = Fluid3D([14806,14330,13705,13744],0); -ELEMENTS[73855] = Fluid3D([7351,7488,7966,8406],0); -ELEMENTS[73856] = Fluid3D([10855,9965,10817,10755],0); -ELEMENTS[73857] = Fluid3D([3502,3065,3458,3669],0); -ELEMENTS[73858] = Fluid3D([5974,5603,5699,6152],0); -ELEMENTS[73859] = Fluid3D([2319,2340,2116,2250],0); -ELEMENTS[73860] = Fluid3D([7040,6745,7431,7692],0); -ELEMENTS[73861] = Fluid3D([17843,17692,17952,18025],0); -ELEMENTS[73862] = Fluid3D([17843,17692,18025,18036],0); -ELEMENTS[73863] = Fluid3D([18025,17843,18036,18099],0); -ELEMENTS[73864] = Fluid3D([18036,18025,18099,18177],0); -ELEMENTS[73865] = Fluid3D([18036,18025,18177,17692],0); -ELEMENTS[73866] = Fluid3D([15687,15267,15462,16040],0); -ELEMENTS[73867] = Fluid3D([15101,14745,14028,13952],0); -ELEMENTS[73868] = Fluid3D([1812,1955,2018,1888],0); -ELEMENTS[73869] = Fluid3D([15556,15963,15347,15241],0); -ELEMENTS[73870] = Fluid3D([15963,15347,15241,15524],0); -ELEMENTS[73871] = Fluid3D([14375,15081,15268,15144],0); -ELEMENTS[73872] = Fluid3D([4562,4829,4173,4731],0); -ELEMENTS[73873] = Fluid3D([6073,5773,6294,6450],0); -ELEMENTS[73874] = Fluid3D([4089,4427,4145,4516],0); -ELEMENTS[73875] = Fluid3D([7647,7917,8615,8488],0); -ELEMENTS[73876] = Fluid3D([7917,8615,8488,8574],0); -ELEMENTS[73877] = Fluid3D([16853,16664,17173,17082],0); -ELEMENTS[73878] = Fluid3D([18602,18663,18609,18600],0); -ELEMENTS[73879] = Fluid3D([15585,15971,15775,16007],0); -ELEMENTS[73880] = Fluid3D([15740,15432,15810,16407],0); -ELEMENTS[73881] = Fluid3D([10960,11002,10712,11779],0); -ELEMENTS[73882] = Fluid3D([5998,6055,5926,5452],0); -ELEMENTS[73883] = Fluid3D([12025,12521,13201,13151],0); -ELEMENTS[73884] = Fluid3D([4584,4758,4792,4170],0); -ELEMENTS[73885] = Fluid3D([4294,4654,4417,5107],0); -ELEMENTS[73886] = Fluid3D([15859,15628,15369,16329],0); -ELEMENTS[73887] = Fluid3D([18287,18098,18240,18276],0); -ELEMENTS[73888] = Fluid3D([18252,18287,18434,18464],0); -ELEMENTS[73889] = Fluid3D([10678,10659,10316,9589],0); -ELEMENTS[73890] = Fluid3D([12085,12961,12496,11710],0); -ELEMENTS[73891] = Fluid3D([8331,8821,8378,8494],0); -ELEMENTS[73892] = Fluid3D([10695,10967,11798,11045],0); -ELEMENTS[73893] = Fluid3D([14462,13870,13530,13762],0); -ELEMENTS[73894] = Fluid3D([8058,9180,9086,8374],0); -ELEMENTS[73895] = Fluid3D([12301,12473,13475,12737],0); -ELEMENTS[73896] = Fluid3D([18636,18550,18646,18601],0); -ELEMENTS[73897] = Fluid3D([1919,1897,1989,1785],0); -ELEMENTS[73898] = Fluid3D([1919,1897,1785,1740],0); -ELEMENTS[73899] = Fluid3D([1785,1919,1740,1870],0); -ELEMENTS[73900] = Fluid3D([15673,15049,15739,15305],0); -ELEMENTS[73901] = Fluid3D([10401,10977,11614,11687],0); -ELEMENTS[73902] = Fluid3D([12065,12721,12234,11488],0); -ELEMENTS[73903] = Fluid3D([12065,12721,11488,12144],0); -ELEMENTS[73904] = Fluid3D([15892,15508,15682,16299],0); -ELEMENTS[73905] = Fluid3D([12824,13005,12674,12047],0); -ELEMENTS[73906] = Fluid3D([15294,15878,15566,15974],0); -ELEMENTS[73907] = Fluid3D([15031,14409,14739,15183],0); -ELEMENTS[73908] = Fluid3D([8296,9115,9119,8816],0); -ELEMENTS[73909] = Fluid3D([8691,9538,9634,9645],0); -ELEMENTS[73910] = Fluid3D([7711,6802,6925,7340],0); -ELEMENTS[73911] = Fluid3D([16782,16769,17286,17143],0); -ELEMENTS[73912] = Fluid3D([17286,16782,17143,16944],0); -ELEMENTS[73913] = Fluid3D([16769,17286,17143,17025],0); -ELEMENTS[73914] = Fluid3D([17286,17143,17025,17366],0); -ELEMENTS[73915] = Fluid3D([15047,15537,15062,14465],0); -ELEMENTS[73916] = Fluid3D([15219,15223,15490,15946],0); -ELEMENTS[73917] = Fluid3D([15096,14986,15483,15844],0); -ELEMENTS[73918] = Fluid3D([15483,15096,15844,15522],0); -ELEMENTS[73919] = Fluid3D([15844,15483,15522,16204],0); -ELEMENTS[73920] = Fluid3D([12804,13343,12694,13058],0); -ELEMENTS[73921] = Fluid3D([16382,15867,16477,15765],0); -ELEMENTS[73922] = Fluid3D([15149,15583,14929,14865],0); -ELEMENTS[73923] = Fluid3D([15583,14929,14865,15820],0); -ELEMENTS[73924] = Fluid3D([18124,17956,18301,18116],0); -ELEMENTS[73925] = Fluid3D([13686,13892,13765,13271],0); -ELEMENTS[73926] = Fluid3D([13686,13892,13271,12409],0); -ELEMENTS[73927] = Fluid3D([7692,7578,6745,7431],0); -ELEMENTS[73928] = Fluid3D([12899,12955,12114,12476],0); -ELEMENTS[73929] = Fluid3D([2425,2627,2846,2568],0); -ELEMENTS[73930] = Fluid3D([9064,8223,8372,8439],0); -ELEMENTS[73931] = Fluid3D([6445,7167,6639,6503],0); -ELEMENTS[73932] = Fluid3D([8840,7950,7883,8776],0); -ELEMENTS[73933] = Fluid3D([3511,3751,3805,4040],0); -ELEMENTS[73934] = Fluid3D([9009,10098,9238,8816],0); -ELEMENTS[73935] = Fluid3D([16825,16623,16405,16002],0); -ELEMENTS[73936] = Fluid3D([12383,13175,12686,12678],0); -ELEMENTS[73937] = Fluid3D([15474,15127,16038,15596],0); -ELEMENTS[73938] = Fluid3D([15353,15214,15904,16021],0); -ELEMENTS[73939] = Fluid3D([15353,15214,16021,15420],0); -ELEMENTS[73940] = Fluid3D([17236,17619,17168,17136],0); -ELEMENTS[73941] = Fluid3D([11367,11721,12348,12761],0); -ELEMENTS[73942] = Fluid3D([9772,9611,10437,10619],0); -ELEMENTS[73943] = Fluid3D([9772,9611,10619,9814],0); -ELEMENTS[73944] = Fluid3D([15339,15503,16030,16213],0); -ELEMENTS[73945] = Fluid3D([11874,11582,11445,11168],0); -ELEMENTS[73946] = Fluid3D([13131,13821,13405,12973],0); -ELEMENTS[73947] = Fluid3D([6873,6164,6748,6396],0); -ELEMENTS[73948] = Fluid3D([8515,8251,9220,9592],0); -ELEMENTS[73949] = Fluid3D([15557,15669,15897,16140],0); -ELEMENTS[73950] = Fluid3D([1964,1976,2186,2109],0); -ELEMENTS[73951] = Fluid3D([7583,8079,8509,7886],0); -ELEMENTS[73952] = Fluid3D([6321,5516,5916,5795],0); -ELEMENTS[73953] = Fluid3D([5843,5373,4977,5165],0); -ELEMENTS[73954] = Fluid3D([8410,9084,8231,8452],0); -ELEMENTS[73955] = Fluid3D([16889,17236,17337,17532],0); -ELEMENTS[73956] = Fluid3D([2727,2688,2998,3148],0); -ELEMENTS[73957] = Fluid3D([13886,14575,13985,13914],0); -ELEMENTS[73958] = Fluid3D([9308,8920,8156,8753],0); -ELEMENTS[73959] = Fluid3D([1889,1987,2118,1910],0); -ELEMENTS[73960] = Fluid3D([10642,10943,11665,11961],0); -ELEMENTS[73961] = Fluid3D([9501,9224,9257,10587],0); -ELEMENTS[73962] = Fluid3D([9501,9224,10587,10298],0); -ELEMENTS[73963] = Fluid3D([15758,15685,15628,16329],0); -ELEMENTS[73964] = Fluid3D([15364,15856,15510,16000],0); -ELEMENTS[73965] = Fluid3D([14381,13762,14462,13530],0); -ELEMENTS[73966] = Fluid3D([14540,14391,14444,15402],0); -ELEMENTS[73967] = Fluid3D([4248,4325,4944,4487],0); -ELEMENTS[73968] = Fluid3D([13503,12818,13043,12153],0); -ELEMENTS[73969] = Fluid3D([6375,7264,6629,6994],0); -ELEMENTS[73970] = Fluid3D([3209,3132,3533,3142],0); -ELEMENTS[73971] = Fluid3D([7795,7819,7014,6762],0); -ELEMENTS[73972] = Fluid3D([5627,5567,6204,5442],0); -ELEMENTS[73973] = Fluid3D([18139,18158,17856,18015],0); -ELEMENTS[73974] = Fluid3D([12414,12777,12481,13610],0); -ELEMENTS[73975] = Fluid3D([16134,15633,16084,16448],0); -ELEMENTS[73976] = Fluid3D([14340,13731,13503,13744],0); -ELEMENTS[73977] = Fluid3D([15658,15587,15321,14854],0); -ELEMENTS[73978] = Fluid3D([7277,6519,6767,7036],0); -ELEMENTS[73979] = Fluid3D([17792,17705,17460,17864],0); -ELEMENTS[73980] = Fluid3D([2174,2300,2078,2464],0); -ELEMENTS[73981] = Fluid3D([13664,13219,12658,13276],0); -ELEMENTS[73982] = Fluid3D([2649,2568,2320,2276],0); -ELEMENTS[73983] = Fluid3D([17025,17366,17621,17286],0); -ELEMENTS[73984] = Fluid3D([13841,13295,14618,14085],0); -ELEMENTS[73985] = Fluid3D([5103,5299,5637,5174],0); -ELEMENTS[73986] = Fluid3D([17795,17565,17868,17895],0); -ELEMENTS[73987] = Fluid3D([9832,9377,9652,9780],0); -ELEMENTS[73988] = Fluid3D([17350,17467,17381,17087],0); -ELEMENTS[73989] = Fluid3D([17467,17381,17087,17481],0); -ELEMENTS[73990] = Fluid3D([3118,3351,3783,3646],0); -ELEMENTS[73991] = Fluid3D([11059,11055,12222,11962],0); -ELEMENTS[73992] = Fluid3D([18165,18290,18394,18242],0); -ELEMENTS[73993] = Fluid3D([12534,12711,12421,11229],0); -ELEMENTS[73994] = Fluid3D([15932,16111,15369,15859],0); -ELEMENTS[73995] = Fluid3D([9460,8642,9725,8587],0); -ELEMENTS[73996] = Fluid3D([7880,7940,8344,9113],0); -ELEMENTS[73997] = Fluid3D([6362,6014,5477,5783],0); -ELEMENTS[73998] = Fluid3D([11777,12664,11941,12964],0); -ELEMENTS[73999] = Fluid3D([8426,8946,9527,8710],0); -ELEMENTS[74000] = Fluid3D([3398,3805,3597,3797],0); -ELEMENTS[74001] = Fluid3D([16508,16070,16628,16577],0); -ELEMENTS[74002] = Fluid3D([14743,14758,14875,15465],0); -ELEMENTS[74003] = Fluid3D([10390,10414,10085,9148],0); -ELEMENTS[74004] = Fluid3D([16602,16718,16358,17055],0); -ELEMENTS[74005] = Fluid3D([8672,8318,8029,7622],0); -ELEMENTS[74006] = Fluid3D([12729,11686,12019,12972],0); -ELEMENTS[74007] = Fluid3D([12729,11686,12972,12241],0); -ELEMENTS[74008] = Fluid3D([5266,4595,4890,4850],0); -ELEMENTS[74009] = Fluid3D([16068,16611,16194,16588],0); -ELEMENTS[74010] = Fluid3D([10642,11665,10975,11961],0); -ELEMENTS[74011] = Fluid3D([7059,7486,7495,8382],0); -ELEMENTS[74012] = Fluid3D([12977,13718,13349,12428],0); -ELEMENTS[74013] = Fluid3D([7347,7197,6636,6306],0); -ELEMENTS[74014] = Fluid3D([2601,2471,2378,2872],0); -ELEMENTS[74015] = Fluid3D([8954,9795,8541,9002],0); -ELEMENTS[74016] = Fluid3D([2143,2037,2186,2289],0); -ELEMENTS[74017] = Fluid3D([10119,10093,10867,9481],0); -ELEMENTS[74018] = Fluid3D([12792,13053,13428,13992],0); -ELEMENTS[74019] = Fluid3D([11358,11845,10871,10308],0); -ELEMENTS[74020] = Fluid3D([16278,16301,16255,16601],0); -ELEMENTS[74021] = Fluid3D([16301,16255,16601,16993],0); -ELEMENTS[74022] = Fluid3D([14229,13479,14571,14072],0); -ELEMENTS[74023] = Fluid3D([17123,16857,16717,17322],0); -ELEMENTS[74024] = Fluid3D([12845,11702,12619,11692],0); -ELEMENTS[74025] = Fluid3D([11897,12977,13161,12085],0); -ELEMENTS[74026] = Fluid3D([3608,3933,4118,4081],0); -ELEMENTS[74027] = Fluid3D([8295,7775,7981,7952],0); -ELEMENTS[74028] = Fluid3D([13804,14542,14335,14021],0); -ELEMENTS[74029] = Fluid3D([6855,7372,7647,6797],0); -ELEMENTS[74030] = Fluid3D([13011,13563,13877,14131],0); -ELEMENTS[74031] = Fluid3D([14495,14741,13948,14891],0); -ELEMENTS[74032] = Fluid3D([4506,4390,5059,4839],0); -ELEMENTS[74033] = Fluid3D([4288,4255,3893,4558],0); -ELEMENTS[74034] = Fluid3D([2466,2721,2820,2480],0); -ELEMENTS[74035] = Fluid3D([2466,2721,2480,2273],0); -ELEMENTS[74036] = Fluid3D([5047,5017,4731,5583],0); -ELEMENTS[74037] = Fluid3D([7459,6643,6995,7442],0); -ELEMENTS[74038] = Fluid3D([6995,7459,7442,7996],0); -ELEMENTS[74039] = Fluid3D([17316,17040,17579,17182],0); -ELEMENTS[74040] = Fluid3D([16410,16074,15655,16077],0); -ELEMENTS[74041] = Fluid3D([4939,5065,5473,4804],0); -ELEMENTS[74042] = Fluid3D([13316,12765,12888,12515],0); -ELEMENTS[74043] = Fluid3D([11874,11168,10357,11582],0); -ELEMENTS[74044] = Fluid3D([8574,9216,9589,9398],0); -ELEMENTS[74045] = Fluid3D([9589,8574,9398,8615],0); -ELEMENTS[74046] = Fluid3D([5950,6709,6770,6696],0); -ELEMENTS[74047] = Fluid3D([15998,16333,15761,16416],0); -ELEMENTS[74048] = Fluid3D([17283,17163,16898,17014],0); -ELEMENTS[74049] = Fluid3D([16898,17283,17014,17136],0); -ELEMENTS[74050] = Fluid3D([7814,7724,7477,6444],0); -ELEMENTS[74051] = Fluid3D([18215,18412,18206,18297],0); -ELEMENTS[74052] = Fluid3D([7302,6466,6853,6671],0); -ELEMENTS[74053] = Fluid3D([7302,6466,6671,6827],0); -ELEMENTS[74054] = Fluid3D([6466,6671,6827,5707],0); -ELEMENTS[74055] = Fluid3D([6466,6671,5707,6042],0); -ELEMENTS[74056] = Fluid3D([6466,6671,6042,6853],0); -ELEMENTS[74057] = Fluid3D([6671,5707,6042,6753],0); -ELEMENTS[74058] = Fluid3D([15807,16305,16266,16097],0); -ELEMENTS[74059] = Fluid3D([15121,14568,14975,15485],0); -ELEMENTS[74060] = Fluid3D([15320,15747,15702,16158],0); -ELEMENTS[74061] = Fluid3D([16240,16013,16619,16704],0); -ELEMENTS[74062] = Fluid3D([13227,13327,13100,13906],0); -ELEMENTS[74063] = Fluid3D([5229,5847,5824,6185],0); -ELEMENTS[74064] = Fluid3D([15697,16106,15553,16394],0); -ELEMENTS[74065] = Fluid3D([8871,9131,7909,8304],0); -ELEMENTS[74066] = Fluid3D([4759,5319,4653,5028],0); -ELEMENTS[74067] = Fluid3D([10586,11543,11300,10775],0); -ELEMENTS[74068] = Fluid3D([10586,11543,10775,10520],0); -ELEMENTS[74069] = Fluid3D([5414,4897,5334,5445],0); -ELEMENTS[74070] = Fluid3D([12507,13225,12147,12884],0); -ELEMENTS[74071] = Fluid3D([16445,16863,16697,16518],0); -ELEMENTS[74072] = Fluid3D([16445,16863,16518,16583],0); -ELEMENTS[74073] = Fluid3D([16445,16863,16583,16280],0); -ELEMENTS[74074] = Fluid3D([13648,14694,14750,13628],0); -ELEMENTS[74075] = Fluid3D([14164,14555,14849,14337],0); -ELEMENTS[74076] = Fluid3D([9652,9780,10825,9832],0); -ELEMENTS[74077] = Fluid3D([15859,15525,15316,16291],0); -ELEMENTS[74078] = Fluid3D([16612,16241,16770,16350],0); -ELEMENTS[74079] = Fluid3D([10831,10807,11447,12016],0); -ELEMENTS[74080] = Fluid3D([10807,11447,12016,12014],0); -ELEMENTS[74081] = Fluid3D([11447,12016,12014,12714],0); -ELEMENTS[74082] = Fluid3D([11570,11118,10432,10372],0); -ELEMENTS[74083] = Fluid3D([9971,9847,9514,10894],0); -ELEMENTS[74084] = Fluid3D([9971,9847,10894,10848],0); -ELEMENTS[74085] = Fluid3D([13577,14300,13913,14308],0); -ELEMENTS[74086] = Fluid3D([6947,6248,6997,6661],0); -ELEMENTS[74087] = Fluid3D([5043,4916,4381,4950],0); -ELEMENTS[74088] = Fluid3D([13902,13532,13683,13470],0); -ELEMENTS[74089] = Fluid3D([13249,12909,12540,13088],0); -ELEMENTS[74090] = Fluid3D([18480,18513,18510,18411],0); -ELEMENTS[74091] = Fluid3D([7112,6553,6372,6669],0); -ELEMENTS[74092] = Fluid3D([7368,6957,7413,6299],0); -ELEMENTS[74093] = Fluid3D([14489,14630,15188,14482],0); -ELEMENTS[74094] = Fluid3D([14432,14421,15021,14413],0); -ELEMENTS[74095] = Fluid3D([7446,7182,6447,7236],0); -ELEMENTS[74096] = Fluid3D([3620,3937,3561,3867],0); -ELEMENTS[74097] = Fluid3D([18558,18438,18486,18559],0); -ELEMENTS[74098] = Fluid3D([6589,7451,6892,6918],0); -ELEMENTS[74099] = Fluid3D([6955,6126,6320,7401],0); -ELEMENTS[74100] = Fluid3D([5307,5976,5772,5654],0); -ELEMENTS[74101] = Fluid3D([5052,5129,4392,4569],0); -ELEMENTS[74102] = Fluid3D([4434,4591,4317,3847],0); -ELEMENTS[74103] = Fluid3D([11076,11925,11649,12336],0); -ELEMENTS[74104] = Fluid3D([17223,17086,17112,17276],0); -ELEMENTS[74105] = Fluid3D([11027,11844,10897,11541],0); -ELEMENTS[74106] = Fluid3D([18439,18290,18517,18307],0); -ELEMENTS[74107] = Fluid3D([5223,4870,4650,5524],0); -ELEMENTS[74108] = Fluid3D([14100,13821,13910,12973],0); -ELEMENTS[74109] = Fluid3D([5572,5963,5494,5250],0); -ELEMENTS[74110] = Fluid3D([6928,7303,7990,7588],0); -ELEMENTS[74111] = Fluid3D([7303,7990,7588,8505],0); -ELEMENTS[74112] = Fluid3D([16378,16381,16965,16525],0); -ELEMENTS[74113] = Fluid3D([6350,5625,6682,5834],0); -ELEMENTS[74114] = Fluid3D([7698,7615,7866,6736],0); -ELEMENTS[74115] = Fluid3D([13099,12798,11898,11862],0); -ELEMENTS[74116] = Fluid3D([16413,16230,16539,15717],0); -ELEMENTS[74117] = Fluid3D([8232,8768,7611,7743],0); -ELEMENTS[74118] = Fluid3D([8232,8768,7743,8381],0); -ELEMENTS[74119] = Fluid3D([8768,7743,8381,7814],0); -ELEMENTS[74120] = Fluid3D([7611,8232,7743,7385],0); -ELEMENTS[74121] = Fluid3D([8232,7743,7385,7833],0); -ELEMENTS[74122] = Fluid3D([7743,7385,7833,7097],0); -ELEMENTS[74123] = Fluid3D([7743,7385,7097,7611],0); -ELEMENTS[74124] = Fluid3D([7833,7743,7097,7163],0); -ELEMENTS[74125] = Fluid3D([7833,7743,7163,7814],0); -ELEMENTS[74126] = Fluid3D([7097,7743,7611,7814],0); -ELEMENTS[74127] = Fluid3D([7097,7743,7814,7163],0); -ELEMENTS[74128] = Fluid3D([8232,7743,7833,8381],0); -ELEMENTS[74129] = Fluid3D([7743,7833,8381,7814],0); -ELEMENTS[74130] = Fluid3D([8232,8768,8381,8243],0); -ELEMENTS[74131] = Fluid3D([7385,7097,7611,6551],0); -ELEMENTS[74132] = Fluid3D([7385,7097,6551,6414],0); -ELEMENTS[74133] = Fluid3D([7097,6551,6414,6558],0); -ELEMENTS[74134] = Fluid3D([7097,6551,6558,7611],0); -ELEMENTS[74135] = Fluid3D([7611,7097,7814,6886],0); -ELEMENTS[74136] = Fluid3D([7097,7814,6886,7163],0); -ELEMENTS[74137] = Fluid3D([7385,7833,7097,7163],0); -ELEMENTS[74138] = Fluid3D([6558,7097,7611,6886],0); -ELEMENTS[74139] = Fluid3D([7743,7611,7814,8768],0); -ELEMENTS[74140] = Fluid3D([18161,17975,17825,18167],0); -ELEMENTS[74141] = Fluid3D([13563,14131,14397,14713],0); -ELEMENTS[74142] = Fluid3D([12912,11771,12727,12266],0); -ELEMENTS[74143] = Fluid3D([11771,12727,12266,11743],0); -ELEMENTS[74144] = Fluid3D([1893,1916,1785,1713],0); -ELEMENTS[74145] = Fluid3D([1785,1893,1713,1872],0); -ELEMENTS[74146] = Fluid3D([6955,6966,6144,6821],0); -ELEMENTS[74147] = Fluid3D([10516,11514,11002,11363],0); -ELEMENTS[74148] = Fluid3D([8296,8143,8166,7213],0); -ELEMENTS[74149] = Fluid3D([17068,17216,17501,17309],0); -ELEMENTS[74150] = Fluid3D([16462,15958,15915,16133],0); -ELEMENTS[74151] = Fluid3D([16611,16874,16588,16068],0); -ELEMENTS[74152] = Fluid3D([6554,6910,7657,7042],0); -ELEMENTS[74153] = Fluid3D([3780,3561,3937,3976],0); -ELEMENTS[74154] = Fluid3D([3780,3561,3976,4015],0); -ELEMENTS[74155] = Fluid3D([3561,3937,3976,3867],0); -ELEMENTS[74156] = Fluid3D([3976,3561,3867,4015],0); -ELEMENTS[74157] = Fluid3D([3867,3976,4015,4394],0); -ELEMENTS[74158] = Fluid3D([3867,3976,4394,3937],0); -ELEMENTS[74159] = Fluid3D([3976,4394,3937,3780],0); -ELEMENTS[74160] = Fluid3D([3976,3780,4015,4394],0); -ELEMENTS[74161] = Fluid3D([5887,6662,6736,6166],0); -ELEMENTS[74162] = Fluid3D([5461,5109,5164,5824],0); -ELEMENTS[74163] = Fluid3D([12529,12991,12693,11925],0); -ELEMENTS[74164] = Fluid3D([8945,9837,9177,8820],0); -ELEMENTS[74165] = Fluid3D([14272,13891,13494,13382],0); -ELEMENTS[74166] = Fluid3D([14907,15104,15769,14870],0); -ELEMENTS[74167] = Fluid3D([14907,15104,14870,13836],0); -ELEMENTS[74168] = Fluid3D([14870,14907,13836,14467],0); -ELEMENTS[74169] = Fluid3D([16371,16898,16667,16504],0); -ELEMENTS[74170] = Fluid3D([4820,5328,4816,4405],0); -ELEMENTS[74171] = Fluid3D([18488,18499,18346,18500],0); -ELEMENTS[74172] = Fluid3D([4025,4280,4281,4745],0); -ELEMENTS[74173] = Fluid3D([15675,16005,15304,15316],0); -ELEMENTS[74174] = Fluid3D([15675,16005,15316,16291],0); -ELEMENTS[74175] = Fluid3D([12501,13172,13311,13483],0); -ELEMENTS[74176] = Fluid3D([12116,12939,12432,13310],0); -ELEMENTS[74177] = Fluid3D([5977,6038,6815,5948],0); -ELEMENTS[74178] = Fluid3D([6682,7544,7231,6350],0); -ELEMENTS[74179] = Fluid3D([17212,16864,16728,16463],0); -ELEMENTS[74180] = Fluid3D([8585,8372,7538,8439],0); -ELEMENTS[74181] = Fluid3D([9571,9398,8615,9589],0); -ELEMENTS[74182] = Fluid3D([9571,9398,9589,10674],0); -ELEMENTS[74183] = Fluid3D([9398,9589,10674,10678],0); -ELEMENTS[74184] = Fluid3D([9398,9589,10678,10316],0); -ELEMENTS[74185] = Fluid3D([4126,3666,3530,3550],0); -ELEMENTS[74186] = Fluid3D([3666,3530,3550,3376],0); -ELEMENTS[74187] = Fluid3D([3074,2932,2912,2577],0); -ELEMENTS[74188] = Fluid3D([16644,16986,16516,17009],0); -ELEMENTS[74189] = Fluid3D([7393,6809,6174,6611],0); -ELEMENTS[74190] = Fluid3D([6809,6174,6611,5953],0); -ELEMENTS[74191] = Fluid3D([7393,6809,6611,7820],0); -ELEMENTS[74192] = Fluid3D([17145,16693,17299,17040],0); -ELEMENTS[74193] = Fluid3D([13484,13027,13153,13579],0); -ELEMENTS[74194] = Fluid3D([17681,17519,17461,17735],0); -ELEMENTS[74195] = Fluid3D([3339,2926,3062,2876],0); -ELEMENTS[74196] = Fluid3D([10704,11781,11004,10815],0); -ELEMENTS[74197] = Fluid3D([10557,10786,9998,10571],0); -ELEMENTS[74198] = Fluid3D([4241,3948,3605,3934],0); -ELEMENTS[74199] = Fluid3D([11291,11296,12143,11667],0); -ELEMENTS[74200] = Fluid3D([17182,17153,16689,16446],0); -ELEMENTS[74201] = Fluid3D([10889,11669,11966,10558],0); -ELEMENTS[74202] = Fluid3D([16258,15694,15676,15747],0); -ELEMENTS[74203] = Fluid3D([10924,9971,10848,9378],0); -ELEMENTS[74204] = Fluid3D([3144,3137,3009,2747],0); -ELEMENTS[74205] = Fluid3D([12156,12195,13004,11987],0); -ELEMENTS[74206] = Fluid3D([12156,12195,11987,11521],0); -ELEMENTS[74207] = Fluid3D([12195,11987,11521,12178],0); -ELEMENTS[74208] = Fluid3D([12156,12195,11521,11240],0); -ELEMENTS[74209] = Fluid3D([11987,12156,11521,10905],0); -ELEMENTS[74210] = Fluid3D([11521,11987,10905,11277],0); -ELEMENTS[74211] = Fluid3D([11521,11987,11277,12178],0); -ELEMENTS[74212] = Fluid3D([12195,13004,11987,13158],0); -ELEMENTS[74213] = Fluid3D([11987,12195,13158,12178],0); -ELEMENTS[74214] = Fluid3D([4204,4742,4414,4182],0); -ELEMENTS[74215] = Fluid3D([9984,9153,9151,9231],0); -ELEMENTS[74216] = Fluid3D([4742,4601,4765,4182],0); -ELEMENTS[74217] = Fluid3D([12808,13226,13017,14145],0); -ELEMENTS[74218] = Fluid3D([13226,13017,14145,13950],0); -ELEMENTS[74219] = Fluid3D([14145,13226,13950,14212],0); -ELEMENTS[74220] = Fluid3D([6504,6802,7299,6530],0); -ELEMENTS[74221] = Fluid3D([10282,9614,9724,9918],0); -ELEMENTS[74222] = Fluid3D([7595,6954,7791,7916],0); -ELEMENTS[74223] = Fluid3D([9551,9901,10359,9203],0); -ELEMENTS[74224] = Fluid3D([18111,18264,18130,17904],0); -ELEMENTS[74225] = Fluid3D([18130,18111,17904,18098],0); -ELEMENTS[74226] = Fluid3D([18111,17904,18098,17731],0); -ELEMENTS[74227] = Fluid3D([14840,15052,15460,14427],0); -ELEMENTS[74228] = Fluid3D([11326,11386,11783,12524],0); -ELEMENTS[74229] = Fluid3D([3867,3370,3561,3620],0); -ELEMENTS[74230] = Fluid3D([14433,14637,14856,13957],0); -ELEMENTS[74231] = Fluid3D([16338,16650,16967,16431],0); -ELEMENTS[74232] = Fluid3D([13910,13131,12973,13821],0); -ELEMENTS[74233] = Fluid3D([15175,15768,15918,15944],0); -ELEMENTS[74234] = Fluid3D([15768,15918,15944,16368],0); -ELEMENTS[74235] = Fluid3D([10771,11305,11489,10458],0); -ELEMENTS[74236] = Fluid3D([18179,18133,18381,18367],0); -ELEMENTS[74237] = Fluid3D([16258,16051,16374,16593],0); -ELEMENTS[74238] = Fluid3D([16374,16258,16593,16784],0); -ELEMENTS[74239] = Fluid3D([16051,16374,16593,16158],0); -ELEMENTS[74240] = Fluid3D([16374,16258,16784,16639],0); -ELEMENTS[74241] = Fluid3D([9812,9192,8623,8710],0); -ELEMENTS[74242] = Fluid3D([9192,8623,8710,8946],0); -ELEMENTS[74243] = Fluid3D([9192,8623,8946,9549],0); -ELEMENTS[74244] = Fluid3D([8946,9192,9549,10232],0); -ELEMENTS[74245] = Fluid3D([8710,9192,8946,9527],0); -ELEMENTS[74246] = Fluid3D([9192,8946,9527,10232],0); -ELEMENTS[74247] = Fluid3D([8710,9192,9527,9812],0); -ELEMENTS[74248] = Fluid3D([9192,9527,9812,10543],0); -ELEMENTS[74249] = Fluid3D([16242,16006,16113,16688],0); -ELEMENTS[74250] = Fluid3D([13925,13321,13807,14175],0); -ELEMENTS[74251] = Fluid3D([12344,12417,12673,11832],0); -ELEMENTS[74252] = Fluid3D([17191,17442,17131,17084],0); -ELEMENTS[74253] = Fluid3D([15862,15910,15548,15254],0); -ELEMENTS[74254] = Fluid3D([15862,15910,15254,15062],0); -ELEMENTS[74255] = Fluid3D([17949,18102,18302,18103],0); -ELEMENTS[74256] = Fluid3D([18302,17949,18103,18247],0); -ELEMENTS[74257] = Fluid3D([17949,18102,18103,17958],0); -ELEMENTS[74258] = Fluid3D([5304,4777,5238,4875],0); -ELEMENTS[74259] = Fluid3D([14255,13720,14286,14507],0); -ELEMENTS[74260] = Fluid3D([6183,6901,6689,6516],0); -ELEMENTS[74261] = Fluid3D([6901,6689,6516,7517],0); -ELEMENTS[74262] = Fluid3D([16637,16427,17115,16813],0); -ELEMENTS[74263] = Fluid3D([5097,5368,5508,4994],0); -ELEMENTS[74264] = Fluid3D([14481,14863,14186,13737],0); -ELEMENTS[74265] = Fluid3D([6536,6216,7260,7117],0); -ELEMENTS[74266] = Fluid3D([7693,7869,8627,8305],0); -ELEMENTS[74267] = Fluid3D([2391,2175,2507,2490],0); -ELEMENTS[74268] = Fluid3D([11456,10781,10290,10243],0); -ELEMENTS[74269] = Fluid3D([7120,7929,7723,7235],0); -ELEMENTS[74270] = Fluid3D([7120,7929,7235,7874],0); -ELEMENTS[74271] = Fluid3D([7235,7120,7874,7895],0); -ELEMENTS[74272] = Fluid3D([7120,7929,7874,7895],0); -ELEMENTS[74273] = Fluid3D([7874,7235,7895,7140],0); -ELEMENTS[74274] = Fluid3D([9086,8655,8058,8374],0); -ELEMENTS[74275] = Fluid3D([13619,13196,14043,13584],0); -ELEMENTS[74276] = Fluid3D([13710,12430,12857,12748],0); -ELEMENTS[74277] = Fluid3D([8778,8670,8387,7514],0); -ELEMENTS[74278] = Fluid3D([9455,9310,9216,8302],0); -ELEMENTS[74279] = Fluid3D([9894,10637,10976,11045],0); -ELEMENTS[74280] = Fluid3D([2771,2930,2792,3248],0); -ELEMENTS[74281] = Fluid3D([14872,14023,14696,14790],0); -ELEMENTS[74282] = Fluid3D([8440,8043,8669,9201],0); -ELEMENTS[74283] = Fluid3D([8669,8440,9201,9361],0); -ELEMENTS[74284] = Fluid3D([14778,15096,14622,15619],0); -ELEMENTS[74285] = Fluid3D([8348,7510,7970,7776],0); -ELEMENTS[74286] = Fluid3D([17692,17952,18025,18177],0); -ELEMENTS[74287] = Fluid3D([16407,16723,16552,16934],0); -ELEMENTS[74288] = Fluid3D([7698,7597,8220,6893],0); -ELEMENTS[74289] = Fluid3D([17274,17075,17351,17314],0); -ELEMENTS[74290] = Fluid3D([1804,1928,1839,2086],0); -ELEMENTS[74291] = Fluid3D([13141,13527,13374,12378],0); -ELEMENTS[74292] = Fluid3D([2635,2477,2727,2998],0); -ELEMENTS[74293] = Fluid3D([9144,8575,9648,8913],0); -ELEMENTS[74294] = Fluid3D([4159,3799,4140,3473],0); -ELEMENTS[74295] = Fluid3D([13349,12728,12245,12481],0); -ELEMENTS[74296] = Fluid3D([12080,12802,12187,13302],0); -ELEMENTS[74297] = Fluid3D([13825,14075,14018,13076],0); -ELEMENTS[74298] = Fluid3D([13999,14639,14466,13769],0); -ELEMENTS[74299] = Fluid3D([5258,4693,4793,5109],0); -ELEMENTS[74300] = Fluid3D([13039,12680,12416,11993],0); -ELEMENTS[74301] = Fluid3D([13039,12680,11993,12983],0); -ELEMENTS[74302] = Fluid3D([15697,16106,16394,16667],0); -ELEMENTS[74303] = Fluid3D([4182,4125,4572,3945],0); -ELEMENTS[74304] = Fluid3D([9829,9679,10827,9884],0); -ELEMENTS[74305] = Fluid3D([13092,12813,12302,13271],0); -ELEMENTS[74306] = Fluid3D([15037,14517,14694,15408],0); -ELEMENTS[74307] = Fluid3D([8640,9029,8163,8751],0); -ELEMENTS[74308] = Fluid3D([8640,9029,8751,9886],0); -ELEMENTS[74309] = Fluid3D([9029,8163,8751,9104],0); -ELEMENTS[74310] = Fluid3D([8751,9029,9104,9706],0); -ELEMENTS[74311] = Fluid3D([8751,9029,9706,9886],0); -ELEMENTS[74312] = Fluid3D([9104,8751,9706,9934],0); -ELEMENTS[74313] = Fluid3D([8751,9706,9934,9886],0); -ELEMENTS[74314] = Fluid3D([9706,9934,9886,10228],0); -ELEMENTS[74315] = Fluid3D([9706,9934,10228,9104],0); -ELEMENTS[74316] = Fluid3D([9886,9706,10228,9029],0); -ELEMENTS[74317] = Fluid3D([10228,9706,9104,9029],0); -ELEMENTS[74318] = Fluid3D([9381,9495,8790,9678],0); -ELEMENTS[74319] = Fluid3D([17735,17525,17519,17442],0); -ELEMENTS[74320] = Fluid3D([9382,9331,9870,10475],0); -ELEMENTS[74321] = Fluid3D([18370,18215,18165,18048],0); -ELEMENTS[74322] = Fluid3D([7085,6119,7027,6084],0); -ELEMENTS[74323] = Fluid3D([2883,3132,2777,2751],0); -ELEMENTS[74324] = Fluid3D([17660,17383,17808,17634],0); -ELEMENTS[74325] = Fluid3D([12998,12751,12026,12464],0); -ELEMENTS[74326] = Fluid3D([13362,13866,14166,14605],0); -ELEMENTS[74327] = Fluid3D([14583,15296,15361,15190],0); -ELEMENTS[74328] = Fluid3D([15781,16129,16223,15534],0); -ELEMENTS[74329] = Fluid3D([16672,17095,17164,17180],0); -ELEMENTS[74330] = Fluid3D([14741,14495,15205,15378],0); -ELEMENTS[74331] = Fluid3D([16125,16016,15697,16667],0); -ELEMENTS[74332] = Fluid3D([17107,17571,17048,17234],0); -ELEMENTS[74333] = Fluid3D([9588,9818,8926,9573],0); -ELEMENTS[74334] = Fluid3D([5882,5625,5649,5070],0); -ELEMENTS[74335] = Fluid3D([15233,15068,14514,14279],0); -ELEMENTS[74336] = Fluid3D([4292,4464,3930,3959],0); -ELEMENTS[74337] = Fluid3D([4292,4464,3959,4302],0); -ELEMENTS[74338] = Fluid3D([4307,3809,3983,4033],0); -ELEMENTS[74339] = Fluid3D([17182,17038,17040,16862],0); -ELEMENTS[74340] = Fluid3D([17182,17038,16862,16446],0); -ELEMENTS[74341] = Fluid3D([17038,16862,16446,17040],0); -ELEMENTS[74342] = Fluid3D([10245,10506,11484,11349],0); -ELEMENTS[74343] = Fluid3D([5932,6606,6376,6258],0); -ELEMENTS[74344] = Fluid3D([15575,15419,15249,16027],0); -ELEMENTS[74345] = Fluid3D([10089,10234,9130,9792],0); -ELEMENTS[74346] = Fluid3D([12680,13524,12416,12762],0); -ELEMENTS[74347] = Fluid3D([12680,13524,12762,13908],0); -ELEMENTS[74348] = Fluid3D([7337,6806,7976,7613],0); -ELEMENTS[74349] = Fluid3D([3015,3370,3314,3061],0); -ELEMENTS[74350] = Fluid3D([14968,15169,15494,15153],0); -ELEMENTS[74351] = Fluid3D([13624,14339,13642,14072],0); -ELEMENTS[74352] = Fluid3D([12208,11658,11910,12842],0); -ELEMENTS[74353] = Fluid3D([5611,4992,5663,5234],0); -ELEMENTS[74354] = Fluid3D([5455,5106,5748,5612],0); -ELEMENTS[74355] = Fluid3D([2288,2124,1964,2109],0); -ELEMENTS[74356] = Fluid3D([8708,9057,8807,9223],0); -ELEMENTS[74357] = Fluid3D([12578,12939,12116,13310],0); -ELEMENTS[74358] = Fluid3D([15033,14354,15021,15145],0); -ELEMENTS[74359] = Fluid3D([15330,14553,14427,14834],0); -ELEMENTS[74360] = Fluid3D([4414,4742,4765,4182],0); -ELEMENTS[74361] = Fluid3D([1856,1919,2075,2064],0); -ELEMENTS[74362] = Fluid3D([7234,7088,7929,8192],0); -ELEMENTS[74363] = Fluid3D([7088,7929,8192,7603],0); -ELEMENTS[74364] = Fluid3D([7929,7234,8192,7895],0); -ELEMENTS[74365] = Fluid3D([17366,16912,17092,17403],0); -ELEMENTS[74366] = Fluid3D([13504,13079,13043,12157],0); -ELEMENTS[74367] = Fluid3D([14722,15199,15345,14873],0); -ELEMENTS[74368] = Fluid3D([17093,16568,16684,16927],0); -ELEMENTS[74369] = Fluid3D([2715,3122,2920,2671],0); -ELEMENTS[74370] = Fluid3D([3411,3583,3334,3057],0); -ELEMENTS[74371] = Fluid3D([14700,14772,15298,15643],0); -ELEMENTS[74372] = Fluid3D([10386,9659,10541,10454],0); -ELEMENTS[74373] = Fluid3D([9993,9363,8747,9801],0); -ELEMENTS[74374] = Fluid3D([14209,14487,14033,13263],0); -ELEMENTS[74375] = Fluid3D([2450,2718,2493,2400],0); -ELEMENTS[74376] = Fluid3D([12694,13091,12851,11708],0); -ELEMENTS[74377] = Fluid3D([16684,16484,16130,16177],0); -ELEMENTS[74378] = Fluid3D([16130,16684,16177,16766],0); -ELEMENTS[74379] = Fluid3D([10382,10018,9966,10363],0); -ELEMENTS[74380] = Fluid3D([12308,12975,12845,11968],0); -ELEMENTS[74381] = Fluid3D([13801,14284,13321,12652],0); -ELEMENTS[74382] = Fluid3D([18186,17998,17923,18012],0); -ELEMENTS[74383] = Fluid3D([7418,7634,8323,8379],0); -ELEMENTS[74384] = Fluid3D([7634,8323,8379,8161],0); -ELEMENTS[74385] = Fluid3D([11212,10850,11277,11819],0); -ELEMENTS[74386] = Fluid3D([17799,17434,17589,17444],0); -ELEMENTS[74387] = Fluid3D([17434,17589,17444,17335],0); -ELEMENTS[74388] = Fluid3D([11473,11847,10552,10638],0); -ELEMENTS[74389] = Fluid3D([16459,16371,16016,16504],0); -ELEMENTS[74390] = Fluid3D([16371,16016,16504,16667],0); -ELEMENTS[74391] = Fluid3D([18149,18157,18075,17863],0); -ELEMENTS[74392] = Fluid3D([12830,13015,11895,12849],0); -ELEMENTS[74393] = Fluid3D([14794,13961,14385,13993],0); -ELEMENTS[74394] = Fluid3D([10147,10349,11381,10742],0); -ELEMENTS[74395] = Fluid3D([6555,5928,6229,5848],0); -ELEMENTS[74396] = Fluid3D([2438,2186,2143,2337],0); -ELEMENTS[74397] = Fluid3D([2186,2143,2337,2109],0); -ELEMENTS[74398] = Fluid3D([15076,15524,15241,15347],0); -ELEMENTS[74399] = Fluid3D([10344,10677,10430,9966],0); -ELEMENTS[74400] = Fluid3D([12117,11813,12435,13056],0); -ELEMENTS[74401] = Fluid3D([4372,4814,4335,4430],0); -ELEMENTS[74402] = Fluid3D([5513,5195,5685,6005],0); -ELEMENTS[74403] = Fluid3D([17864,17705,18095,17792],0); -ELEMENTS[74404] = Fluid3D([16765,16412,16054,16063],0); -ELEMENTS[74405] = Fluid3D([6889,7648,8289,7882],0); -ELEMENTS[74406] = Fluid3D([6688,7224,7222,6245],0); -ELEMENTS[74407] = Fluid3D([18526,18412,18421,18548],0); -ELEMENTS[74408] = Fluid3D([18421,18526,18548,18562],0); -ELEMENTS[74409] = Fluid3D([18673,18650,18690,18681],0); -ELEMENTS[74410] = Fluid3D([12260,11979,12813,12128],0); -ELEMENTS[74411] = Fluid3D([10897,11851,10561,11541],0); -ELEMENTS[74412] = Fluid3D([13280,13628,13201,12969],0); -ELEMENTS[74413] = Fluid3D([13280,13628,12969,14073],0); -ELEMENTS[74414] = Fluid3D([16449,16580,15849,16207],0); -ELEMENTS[74415] = Fluid3D([16449,16580,16207,16699],0); -ELEMENTS[74416] = Fluid3D([8161,8961,8429,8882],0); -ELEMENTS[74417] = Fluid3D([8161,8961,8882,9285],0); -ELEMENTS[74418] = Fluid3D([1911,1795,1840,1932],0); -ELEMENTS[74419] = Fluid3D([1911,1795,1932,2009],0); -ELEMENTS[74420] = Fluid3D([14557,13827,14699,13857],0); -ELEMENTS[74421] = Fluid3D([10613,10337,11492,11358],0); -ELEMENTS[74422] = Fluid3D([10968,12001,11387,12020],0); -ELEMENTS[74423] = Fluid3D([7129,7409,7763,8515],0); -ELEMENTS[74424] = Fluid3D([15136,15815,15617,15378],0); -ELEMENTS[74425] = Fluid3D([17638,17590,17972,17623],0); -ELEMENTS[74426] = Fluid3D([17638,17590,17623,17354],0); -ELEMENTS[74427] = Fluid3D([12645,11721,12719,12761],0); -ELEMENTS[74428] = Fluid3D([12968,13486,12165,12200],0); -ELEMENTS[74429] = Fluid3D([11164,9945,10086,9848],0); -ELEMENTS[74430] = Fluid3D([9945,10086,9848,8895],0); -ELEMENTS[74431] = Fluid3D([10086,11164,9848,9962],0); -ELEMENTS[74432] = Fluid3D([9848,10086,9962,8745],0); -ELEMENTS[74433] = Fluid3D([4070,4300,4450,3692],0); -ELEMENTS[74434] = Fluid3D([8296,9115,8816,8166],0); -ELEMENTS[74435] = Fluid3D([17677,17540,17794,17943],0); -ELEMENTS[74436] = Fluid3D([14665,15249,14296,14661],0); -ELEMENTS[74437] = Fluid3D([1873,2037,2083,1915],0); -ELEMENTS[74438] = Fluid3D([1873,2037,1915,1809],0); -ELEMENTS[74439] = Fluid3D([4196,4241,4583,4037],0); -ELEMENTS[74440] = Fluid3D([9316,8991,8672,8721],0); -ELEMENTS[74441] = Fluid3D([9316,8991,8721,10109],0); -ELEMENTS[74442] = Fluid3D([9216,8918,9310,10316],0); -ELEMENTS[74443] = Fluid3D([11862,11898,11418,12798],0); -ELEMENTS[74444] = Fluid3D([5309,5507,5139,5794],0); -ELEMENTS[74445] = Fluid3D([2471,2460,2365,2744],0); -ELEMENTS[74446] = Fluid3D([2471,2460,2744,2778],0); -ELEMENTS[74447] = Fluid3D([2744,2471,2778,2872],0); -ELEMENTS[74448] = Fluid3D([13601,13262,13202,12561],0); -ELEMENTS[74449] = Fluid3D([11732,10757,11188,12186],0); -ELEMENTS[74450] = Fluid3D([16609,16513,15842,16246],0); -ELEMENTS[74451] = Fluid3D([17031,16697,16394,16445],0); -ELEMENTS[74452] = Fluid3D([17073,17520,17225,17174],0); -ELEMENTS[74453] = Fluid3D([15526,15871,15999,15780],0); -ELEMENTS[74454] = Fluid3D([18552,18434,18591,18506],0); -ELEMENTS[74455] = Fluid3D([16280,16574,16024,16798],0); -ELEMENTS[74456] = Fluid3D([15419,14661,15234,15073],0); -ELEMENTS[74457] = Fluid3D([4141,4691,4743,4506],0); -ELEMENTS[74458] = Fluid3D([4059,4477,4419,3932],0); -ELEMENTS[74459] = Fluid3D([4419,4059,3932,4036],0); -ELEMENTS[74460] = Fluid3D([18413,18486,18497,18521],0); -ELEMENTS[74461] = Fluid3D([16145,16687,16879,16716],0); -ELEMENTS[74462] = Fluid3D([16145,16004,15703,15714],0); -ELEMENTS[74463] = Fluid3D([7123,6617,6656,5948],0); -ELEMENTS[74464] = Fluid3D([11707,10789,10867,10520],0); -ELEMENTS[74465] = Fluid3D([3842,3908,3592,4091],0); -ELEMENTS[74466] = Fluid3D([12730,13785,13040,13707],0); -ELEMENTS[74467] = Fluid3D([11241,11197,12163,11373],0); -ELEMENTS[74468] = Fluid3D([3883,3819,3720,3245],0); -ELEMENTS[74469] = Fluid3D([11306,12196,12218,12699],0); -ELEMENTS[74470] = Fluid3D([13776,13295,14085,14696],0); -ELEMENTS[74471] = Fluid3D([15072,14355,15062,14764],0); -ELEMENTS[74472] = Fluid3D([3437,3675,3388,3077],0); -ELEMENTS[74473] = Fluid3D([13291,13547,13390,12421],0); -ELEMENTS[74474] = Fluid3D([7889,7965,8997,8648],0); -ELEMENTS[74475] = Fluid3D([16365,15936,15797,15840],0); -ELEMENTS[74476] = Fluid3D([12824,12728,12481,11554],0); -ELEMENTS[74477] = Fluid3D([7750,8670,7514,8524],0); -ELEMENTS[74478] = Fluid3D([7750,8670,8524,8302],0); -ELEMENTS[74479] = Fluid3D([16304,16411,16775,16239],0); -ELEMENTS[74480] = Fluid3D([17731,17904,17875,18111],0); -ELEMENTS[74481] = Fluid3D([5129,4821,4392,4482],0); -ELEMENTS[74482] = Fluid3D([5482,5507,5622,4965],0); -ELEMENTS[74483] = Fluid3D([17825,17576,18033,17609],0); -ELEMENTS[74484] = Fluid3D([10326,9262,10309,9884],0); -ELEMENTS[74485] = Fluid3D([17744,17668,17563,17988],0); -ELEMENTS[74486] = Fluid3D([10232,11000,11073,10778],0); -ELEMENTS[74487] = Fluid3D([16255,16627,16993,16653],0); -ELEMENTS[74488] = Fluid3D([10850,11277,11819,10447],0); -ELEMENTS[74489] = Fluid3D([3659,3351,3357,3420],0); -ELEMENTS[74490] = Fluid3D([10954,10543,11797,11671],0); -ELEMENTS[74491] = Fluid3D([15605,16225,15814,15762],0); -ELEMENTS[74492] = Fluid3D([15605,16225,15762,15904],0); -ELEMENTS[74493] = Fluid3D([4135,4061,3546,3596],0); -ELEMENTS[74494] = Fluid3D([15319,15326,15728,16121],0); -ELEMENTS[74495] = Fluid3D([2483,2298,2485,2198],0); -ELEMENTS[74496] = Fluid3D([7135,7960,7717,7870],0); -ELEMENTS[74497] = Fluid3D([7135,7960,7870,6772],0); -ELEMENTS[74498] = Fluid3D([16294,16201,15927,16858],0); -ELEMENTS[74499] = Fluid3D([13243,13766,13959,14452],0); -ELEMENTS[74500] = Fluid3D([13766,13959,14452,14355],0); -ELEMENTS[74501] = Fluid3D([18220,18438,18288,18397],0); -ELEMENTS[74502] = Fluid3D([15935,16311,16166,15973],0); -ELEMENTS[74503] = Fluid3D([4022,4133,3589,4352],0); -ELEMENTS[74504] = Fluid3D([13442,13474,14320,14008],0); -ELEMENTS[74505] = Fluid3D([5905,6307,6942,6162],0); -ELEMENTS[74506] = Fluid3D([2075,1919,1989,2116],0); -ELEMENTS[74507] = Fluid3D([6316,7158,6191,6746],0); -ELEMENTS[74508] = Fluid3D([16986,17487,17365,17032],0); -ELEMENTS[74509] = Fluid3D([2683,2997,3077,3198],0); -ELEMENTS[74510] = Fluid3D([17908,17881,17537,17484],0); -ELEMENTS[74511] = Fluid3D([6815,6038,6617,5948],0); -ELEMENTS[74512] = Fluid3D([4930,4794,5535,5195],0); -ELEMENTS[74513] = Fluid3D([15816,16010,16300,15297],0); -ELEMENTS[74514] = Fluid3D([10479,10086,9323,8745],0); -ELEMENTS[74515] = Fluid3D([18167,18161,17986,17825],0); -ELEMENTS[74516] = Fluid3D([15632,15955,16190,15405],0); -ELEMENTS[74517] = Fluid3D([16014,16072,16453,16730],0); -ELEMENTS[74518] = Fluid3D([16453,16014,16730,16586],0); -ELEMENTS[74519] = Fluid3D([6450,6396,7126,7395],0); -ELEMENTS[74520] = Fluid3D([13157,12543,13337,12174],0); -ELEMENTS[74521] = Fluid3D([10788,10742,12082,11726],0); -ELEMENTS[74522] = Fluid3D([12730,13785,13707,13334],0); -ELEMENTS[74523] = Fluid3D([9510,9985,9962,10928],0); -ELEMENTS[74524] = Fluid3D([3959,3787,3523,4292],0); -ELEMENTS[74525] = Fluid3D([11662,12170,12052,10626],0); -ELEMENTS[74526] = Fluid3D([17938,18158,17889,17856],0); -ELEMENTS[74527] = Fluid3D([15109,15167,14453,14117],0); -ELEMENTS[74528] = Fluid3D([10873,11786,11969,10571],0); -ELEMENTS[74529] = Fluid3D([10873,11786,10571,11647],0); -ELEMENTS[74530] = Fluid3D([17295,17081,16799,16932],0); -ELEMENTS[74531] = Fluid3D([16024,16278,16601,16798],0); -ELEMENTS[74532] = Fluid3D([16024,16278,16798,16574],0); -ELEMENTS[74533] = Fluid3D([16024,16278,16574,16149],0); -ELEMENTS[74534] = Fluid3D([16278,16798,16574,16693],0); -ELEMENTS[74535] = Fluid3D([16278,16798,16693,16601],0); -ELEMENTS[74536] = Fluid3D([15852,15165,15036,15674],0); -ELEMENTS[74537] = Fluid3D([5981,5371,5844,6190],0); -ELEMENTS[74538] = Fluid3D([12975,13197,14054,13559],0); -ELEMENTS[74539] = Fluid3D([13185,13077,12327,13144],0); -ELEMENTS[74540] = Fluid3D([8453,8955,7845,8213],0); -ELEMENTS[74541] = Fluid3D([10461,10368,11232,10580],0); -ELEMENTS[74542] = Fluid3D([6950,6367,6476,6495],0); -ELEMENTS[74543] = Fluid3D([10982,10115,10273,9676],0); -ELEMENTS[74544] = Fluid3D([11275,12087,11033,11272],0); -ELEMENTS[74545] = Fluid3D([17189,17069,17287,17566],0); -ELEMENTS[74546] = Fluid3D([7492,7622,6900,6706],0); -ELEMENTS[74547] = Fluid3D([5556,5969,6406,5419],0); -ELEMENTS[74548] = Fluid3D([11402,10669,11960,11826],0); -ELEMENTS[74549] = Fluid3D([15682,16408,15892,16299],0); -ELEMENTS[74550] = Fluid3D([15199,15345,15774,15054],0); -ELEMENTS[74551] = Fluid3D([5881,5917,5546,5043],0); -ELEMENTS[74552] = Fluid3D([5585,5377,5091,5787],0); -ELEMENTS[74553] = Fluid3D([2727,2948,3290,2998],0); -ELEMENTS[74554] = Fluid3D([2727,2948,2998,2611],0); -ELEMENTS[74555] = Fluid3D([8727,8048,7733,7661],0); -ELEMENTS[74556] = Fluid3D([8048,7733,7661,6988],0); -ELEMENTS[74557] = Fluid3D([5402,4918,5091,5279],0); -ELEMENTS[74558] = Fluid3D([7442,7459,7886,8441],0); -ELEMENTS[74559] = Fluid3D([7886,7442,8441,7298],0); -ELEMENTS[74560] = Fluid3D([7886,7442,7298,6643],0); -ELEMENTS[74561] = Fluid3D([7917,8574,8916,8615],0); -ELEMENTS[74562] = Fluid3D([16983,16767,17271,17035],0); -ELEMENTS[74563] = Fluid3D([12721,13093,12234,13190],0); -ELEMENTS[74564] = Fluid3D([12889,12435,13020,12519],0); -ELEMENTS[74565] = Fluid3D([12889,12435,12519,11442],0); -ELEMENTS[74566] = Fluid3D([12889,12435,11442,12010],0); -ELEMENTS[74567] = Fluid3D([8905,9902,9774,9761],0); -ELEMENTS[74568] = Fluid3D([4462,5144,4891,4751],0); -ELEMENTS[74569] = Fluid3D([8710,8988,8860,9970],0); -ELEMENTS[74570] = Fluid3D([16233,15865,16396,15572],0); -ELEMENTS[74571] = Fluid3D([9688,9517,9374,8550],0); -ELEMENTS[74572] = Fluid3D([8402,7566,8322,8497],0); -ELEMENTS[74573] = Fluid3D([17839,17857,17515,17787],0); -ELEMENTS[74574] = Fluid3D([5719,5368,5694,5985],0); -ELEMENTS[74575] = Fluid3D([12541,11729,12190,13073],0); -ELEMENTS[74576] = Fluid3D([11220,12037,11621,10696],0); -ELEMENTS[74577] = Fluid3D([7363,7129,7396,8204],0); -ELEMENTS[74578] = Fluid3D([8819,7880,8649,8353],0); -ELEMENTS[74579] = Fluid3D([5582,6174,5828,5398],0); -ELEMENTS[74580] = Fluid3D([10545,11391,11256,10269],0); -ELEMENTS[74581] = Fluid3D([14929,15191,14843,15820],0); -ELEMENTS[74582] = Fluid3D([2558,2509,2825,2568],0); -ELEMENTS[74583] = Fluid3D([2825,2558,2568,2627],0); -ELEMENTS[74584] = Fluid3D([17157,17438,17758,17415],0); -ELEMENTS[74585] = Fluid3D([5433,5977,5948,5522],0); -ELEMENTS[74586] = Fluid3D([11743,10975,11665,11961],0); -ELEMENTS[74587] = Fluid3D([17176,17214,17655,17325],0); -ELEMENTS[74588] = Fluid3D([16594,16877,16828,16529],0); -ELEMENTS[74589] = Fluid3D([15539,15083,15160,14956],0); -ELEMENTS[74590] = Fluid3D([17129,16804,16687,16606],0); -ELEMENTS[74591] = Fluid3D([7208,6953,7921,7112],0); -ELEMENTS[74592] = Fluid3D([1928,2065,2001,2086],0); -ELEMENTS[74593] = Fluid3D([2460,2314,2503,2204],0); -ELEMENTS[74594] = Fluid3D([13818,13085,12891,12704],0); -ELEMENTS[74595] = Fluid3D([15030,15239,15698,14999],0); -ELEMENTS[74596] = Fluid3D([5292,5542,4757,4940],0); -ELEMENTS[74597] = Fluid3D([16912,17092,17403,16722],0); -ELEMENTS[74598] = Fluid3D([16912,17092,16722,16765],0); -ELEMENTS[74599] = Fluid3D([3458,3502,3669,3906],0); -ELEMENTS[74600] = Fluid3D([5748,5612,6330,5455],0); -ELEMENTS[74601] = Fluid3D([18474,18606,18639,18577],0); -ELEMENTS[74602] = Fluid3D([16509,16793,16396,16407],0); -ELEMENTS[74603] = Fluid3D([14778,14258,15123,14464],0); -ELEMENTS[74604] = Fluid3D([15123,14778,14464,15194],0); -ELEMENTS[74605] = Fluid3D([14778,14258,14464,14438],0); -ELEMENTS[74606] = Fluid3D([14464,14778,14438,15194],0); -ELEMENTS[74607] = Fluid3D([14778,14438,15194,15619],0); -ELEMENTS[74608] = Fluid3D([14778,14258,14438,14622],0); -ELEMENTS[74609] = Fluid3D([14438,14778,14622,15619],0); -ELEMENTS[74610] = Fluid3D([14438,14464,15194,14731],0); -ELEMENTS[74611] = Fluid3D([13198,13926,13616,14237],0); -ELEMENTS[74612] = Fluid3D([9334,8763,8530,8375],0); -ELEMENTS[74613] = Fluid3D([5164,5258,5610,5824],0); -ELEMENTS[74614] = Fluid3D([5164,5258,5824,5109],0); -ELEMENTS[74615] = Fluid3D([10495,9983,10958,10956],0); -ELEMENTS[74616] = Fluid3D([16581,16088,16225,16558],0); -ELEMENTS[74617] = Fluid3D([5659,5077,5880,5143],0); -ELEMENTS[74618] = Fluid3D([8091,8778,7935,7514],0); -ELEMENTS[74619] = Fluid3D([1618,1722,1693,1803],0); -ELEMENTS[74620] = Fluid3D([1722,1693,1803,1932],0); -ELEMENTS[74621] = Fluid3D([13290,12968,12083,12200],0); -ELEMENTS[74622] = Fluid3D([5391,5914,5818,5418],0); -ELEMENTS[74623] = Fluid3D([8427,7880,8344,9113],0); -ELEMENTS[74624] = Fluid3D([9793,9152,10238,8970],0); -ELEMENTS[74625] = Fluid3D([9793,9152,8970,8784],0); -ELEMENTS[74626] = Fluid3D([18540,18531,18397,18416],0); -ELEMENTS[74627] = Fluid3D([9287,8803,9950,8979],0); -ELEMENTS[74628] = Fluid3D([11847,12405,11278,11286],0); -ELEMENTS[74629] = Fluid3D([11278,11847,11286,10552],0); -ELEMENTS[74630] = Fluid3D([7623,7289,8161,7063],0); -ELEMENTS[74631] = Fluid3D([18450,18586,18478,18590],0); -ELEMENTS[74632] = Fluid3D([17926,17623,17449,17695],0); -ELEMENTS[74633] = Fluid3D([5998,5642,6220,6093],0); -ELEMENTS[74634] = Fluid3D([8520,9201,8043,8288],0); -ELEMENTS[74635] = Fluid3D([15480,14781,15297,15025],0); -ELEMENTS[74636] = Fluid3D([8124,7315,7595,7910],0); -ELEMENTS[74637] = Fluid3D([10149,9427,9247,9556],0); -ELEMENTS[74638] = Fluid3D([5218,4871,5445,5598],0); -ELEMENTS[74639] = Fluid3D([18242,18056,18352,18165],0); -ELEMENTS[74640] = Fluid3D([2009,2134,2214,1911],0); -ELEMENTS[74641] = Fluid3D([2026,2283,2034,2193],0); -ELEMENTS[74642] = Fluid3D([18015,18056,18312,18136],0); -ELEMENTS[74643] = Fluid3D([9183,9271,10318,10206],0); -ELEMENTS[74644] = Fluid3D([17845,17986,17779,17536],0); -ELEMENTS[74645] = Fluid3D([12522,13410,12384,12836],0); -ELEMENTS[74646] = Fluid3D([12522,13410,12836,12985],0); -ELEMENTS[74647] = Fluid3D([7172,6986,7929,7723],0); -ELEMENTS[74648] = Fluid3D([10435,10772,11676,11558],0); -ELEMENTS[74649] = Fluid3D([18450,18478,18437,18590],0); -ELEMENTS[74650] = Fluid3D([16204,15844,16036,15610],0); -ELEMENTS[74651] = Fluid3D([16204,15844,15610,15522],0); -ELEMENTS[74652] = Fluid3D([15610,16204,15522,15562],0); -ELEMENTS[74653] = Fluid3D([15522,15610,15562,15325],0); -ELEMENTS[74654] = Fluid3D([15610,15562,15325,16036],0); -ELEMENTS[74655] = Fluid3D([15325,15610,16036,15844],0); -ELEMENTS[74656] = Fluid3D([15522,15610,15325,15096],0); -ELEMENTS[74657] = Fluid3D([15610,15325,15096,15844],0); -ELEMENTS[74658] = Fluid3D([16036,16204,15610,15562],0); -ELEMENTS[74659] = Fluid3D([15844,15610,15522,15096],0); -ELEMENTS[74660] = Fluid3D([14330,13586,13705,13504],0); -ELEMENTS[74661] = Fluid3D([14330,13586,13504,14444],0); -ELEMENTS[74662] = Fluid3D([14330,13586,14444,13955],0); -ELEMENTS[74663] = Fluid3D([3549,3682,3286,3684],0); -ELEMENTS[74664] = Fluid3D([17493,17045,17080,17239],0); -ELEMENTS[74665] = Fluid3D([17080,17493,17239,17532],0); -ELEMENTS[74666] = Fluid3D([13231,13262,12561,12324],0); -ELEMENTS[74667] = Fluid3D([6240,5608,6110,5400],0); -ELEMENTS[74668] = Fluid3D([5608,6110,5400,5671],0); -ELEMENTS[74669] = Fluid3D([4181,3780,4310,4442],0); -ELEMENTS[74670] = Fluid3D([12560,13154,12657,13790],0); -ELEMENTS[74671] = Fluid3D([13154,12657,13790,13217],0); -ELEMENTS[74672] = Fluid3D([15642,15334,16153,15967],0); -ELEMENTS[74673] = Fluid3D([11249,12001,12441,11387],0); -ELEMENTS[74674] = Fluid3D([3563,3726,4225,3838],0); -ELEMENTS[74675] = Fluid3D([10519,10350,9521,9728],0); -ELEMENTS[74676] = Fluid3D([18433,18418,18335,18391],0); -ELEMENTS[74677] = Fluid3D([17972,18080,17791,17623],0); -ELEMENTS[74678] = Fluid3D([15957,16012,16700,16057],0); -ELEMENTS[74679] = Fluid3D([17365,17487,17736,17398],0); -ELEMENTS[74680] = Fluid3D([17736,17365,17398,17327],0); -ELEMENTS[74681] = Fluid3D([17365,17487,17398,17032],0); -ELEMENTS[74682] = Fluid3D([17398,17365,17032,16922],0); -ELEMENTS[74683] = Fluid3D([13691,12612,13052,13161],0); -ELEMENTS[74684] = Fluid3D([13052,13691,13161,14103],0); -ELEMENTS[74685] = Fluid3D([8735,8043,9201,8288],0); -ELEMENTS[74686] = Fluid3D([13444,12750,12928,13598],0); -ELEMENTS[74687] = Fluid3D([12955,13077,11739,12476],0); -ELEMENTS[74688] = Fluid3D([9236,9601,8475,9120],0); -ELEMENTS[74689] = Fluid3D([8913,9485,9648,9144],0); -ELEMENTS[74690] = Fluid3D([17106,17025,16910,16366],0); -ELEMENTS[74691] = Fluid3D([5457,5190,5452,5469],0); -ELEMENTS[74692] = Fluid3D([2872,3206,3129,2928],0); -ELEMENTS[74693] = Fluid3D([10634,9858,9681,10241],0); -ELEMENTS[74694] = Fluid3D([13864,14630,13677,14132],0); -ELEMENTS[74695] = Fluid3D([17860,17866,18086,17720],0); -ELEMENTS[74696] = Fluid3D([14994,14934,15882,15739],0); -ELEMENTS[74697] = Fluid3D([10218,10434,11386,11187],0); -ELEMENTS[74698] = Fluid3D([4811,5002,5108,5682],0); -ELEMENTS[74699] = Fluid3D([5250,5053,5572,5963],0); -ELEMENTS[74700] = Fluid3D([4853,5218,4489,4772],0); -ELEMENTS[74701] = Fluid3D([7244,7757,6911,6386],0); -ELEMENTS[74702] = Fluid3D([10791,10398,11619,11821],0); -ELEMENTS[74703] = Fluid3D([7972,7692,7062,7629],0); -ELEMENTS[74704] = Fluid3D([12803,12037,12234,13190],0); -ELEMENTS[74705] = Fluid3D([10447,11521,11277,11819],0); -ELEMENTS[74706] = Fluid3D([15815,15136,15205,15378],0); -ELEMENTS[74707] = Fluid3D([3193,3593,3527,3460],0); -ELEMENTS[74708] = Fluid3D([6599,6552,5866,5791],0); -ELEMENTS[74709] = Fluid3D([12333,11996,11104,12273],0); -ELEMENTS[74710] = Fluid3D([14183,14964,15149,14270],0); -ELEMENTS[74711] = Fluid3D([12680,13455,12568,12983],0); -ELEMENTS[74712] = Fluid3D([18038,17996,18041,17782],0); -ELEMENTS[74713] = Fluid3D([15641,15303,15660,15404],0); -ELEMENTS[74714] = Fluid3D([15641,15303,15404,14607],0); -ELEMENTS[74715] = Fluid3D([4449,4368,4459,4983],0); -ELEMENTS[74716] = Fluid3D([14908,14311,13845,14802],0); -ELEMENTS[74717] = Fluid3D([6248,5996,5352,5602],0); -ELEMENTS[74718] = Fluid3D([5996,5352,5602,5615],0); -ELEMENTS[74719] = Fluid3D([4918,5100,5743,5091],0); -ELEMENTS[74720] = Fluid3D([17226,16894,17312,16979],0); -ELEMENTS[74721] = Fluid3D([16416,15993,16229,16537],0); -ELEMENTS[74722] = Fluid3D([16416,15993,16537,16290],0); -ELEMENTS[74723] = Fluid3D([3898,3763,4441,4352],0); -ELEMENTS[74724] = Fluid3D([2727,2518,2948,2498],0); -ELEMENTS[74725] = Fluid3D([13174,13630,12934,12808],0); -ELEMENTS[74726] = Fluid3D([13144,13451,13185,14132],0); -ELEMENTS[74727] = Fluid3D([11294,10795,10822,12094],0); -ELEMENTS[74728] = Fluid3D([6090,5489,6193,5848],0); -ELEMENTS[74729] = Fluid3D([12660,13046,12738,13898],0); -ELEMENTS[74730] = Fluid3D([9226,9725,9184,8642],0); -ELEMENTS[74731] = Fluid3D([4811,4490,4129,4542],0); -ELEMENTS[74732] = Fluid3D([6893,6148,6461,7491],0); -ELEMENTS[74733] = Fluid3D([17510,17566,17100,17215],0); -ELEMENTS[74734] = Fluid3D([2350,2264,2437,2578],0); -ELEMENTS[74735] = Fluid3D([3723,4010,4436,4352],0); -ELEMENTS[74736] = Fluid3D([4184,4538,4561,4909],0); -ELEMENTS[74737] = Fluid3D([13815,13593,14178,12907],0); -ELEMENTS[74738] = Fluid3D([17291,16801,16945,17180],0); -ELEMENTS[74739] = Fluid3D([2654,2980,2843,2547],0); -ELEMENTS[74740] = Fluid3D([14608,14300,15046,15535],0); -ELEMENTS[74741] = Fluid3D([2092,1939,1809,1976],0); -ELEMENTS[74742] = Fluid3D([2092,1939,1976,2186],0); -ELEMENTS[74743] = Fluid3D([17754,17610,17968,17819],0); -ELEMENTS[74744] = Fluid3D([15293,15043,14546,14310],0); -ELEMENTS[74745] = Fluid3D([13790,13933,13836,13217],0); -ELEMENTS[74746] = Fluid3D([6965,6710,6090,6456],0); -ELEMENTS[74747] = Fluid3D([6090,6965,6456,6091],0); -ELEMENTS[74748] = Fluid3D([6456,6090,6091,5969],0); -ELEMENTS[74749] = Fluid3D([6456,6090,5969,6234],0); -ELEMENTS[74750] = Fluid3D([6456,6090,6234,6710],0); -ELEMENTS[74751] = Fluid3D([12909,12826,13404,12425],0); -ELEMENTS[74752] = Fluid3D([13705,13079,13504,12803],0); -ELEMENTS[74753] = Fluid3D([13079,13504,12803,12157],0); -ELEMENTS[74754] = Fluid3D([4309,4886,4397,4208],0); -ELEMENTS[74755] = Fluid3D([4445,4092,4604,4922],0); -ELEMENTS[74756] = Fluid3D([3856,4267,3612,4318],0); -ELEMENTS[74757] = Fluid3D([15644,15726,16207,15849],0); -ELEMENTS[74758] = Fluid3D([15198,14958,15262,14374],0); -ELEMENTS[74759] = Fluid3D([12435,12406,13056,13360],0); -ELEMENTS[74760] = Fluid3D([12441,13125,12001,11855],0); -ELEMENTS[74761] = Fluid3D([2171,2010,2152,2200],0); -ELEMENTS[74762] = Fluid3D([10666,9774,9902,9761],0); -ELEMENTS[74763] = Fluid3D([17271,17083,17428,16805],0); -ELEMENTS[74764] = Fluid3D([16783,16834,16246,16340],0); -ELEMENTS[74765] = Fluid3D([11849,12125,11346,10869],0); -ELEMENTS[74766] = Fluid3D([9622,8468,9386,9308],0); -ELEMENTS[74767] = Fluid3D([9386,9622,9308,10003],0); -ELEMENTS[74768] = Fluid3D([16364,16408,16799,16555],0); -ELEMENTS[74769] = Fluid3D([16799,16364,16555,16160],0); -ELEMENTS[74770] = Fluid3D([16364,16408,16555,15892],0); -ELEMENTS[74771] = Fluid3D([17129,17200,16981,16606],0); -ELEMENTS[74772] = Fluid3D([17542,17065,17032,17487],0); -ELEMENTS[74773] = Fluid3D([14645,13930,14258,13435],0); -ELEMENTS[74774] = Fluid3D([15944,15936,15175,15768],0); -ELEMENTS[74775] = Fluid3D([6201,5797,5393,5909],0); -ELEMENTS[74776] = Fluid3D([4870,5223,5771,5524],0); -ELEMENTS[74777] = Fluid3D([9903,9543,9365,10058],0); -ELEMENTS[74778] = Fluid3D([16546,16570,15918,16368],0); -ELEMENTS[74779] = Fluid3D([8645,7886,9135,8509],0); -ELEMENTS[74780] = Fluid3D([9286,9294,9062,10207],0); -ELEMENTS[74781] = Fluid3D([8492,8783,9499,8455],0); -ELEMENTS[74782] = Fluid3D([8548,7674,8186,8285],0); -ELEMENTS[74783] = Fluid3D([14262,13518,13123,13863],0); -ELEMENTS[74784] = Fluid3D([5418,5476,5391,5914],0); -ELEMENTS[74785] = Fluid3D([17627,17383,17352,17700],0); -ELEMENTS[74786] = Fluid3D([9094,9350,10400,10115],0); -ELEMENTS[74787] = Fluid3D([16674,16221,16535,16985],0); -ELEMENTS[74788] = Fluid3D([6543,7475,6442,7213],0); -ELEMENTS[74789] = Fluid3D([12308,11401,11968,12845],0); -ELEMENTS[74790] = Fluid3D([17094,17183,17459,17723],0); -ELEMENTS[74791] = Fluid3D([14417,14453,15246,14975],0); -ELEMENTS[74792] = Fluid3D([10964,10282,11593,10514],0); -ELEMENTS[74793] = Fluid3D([2482,2566,2602,2464],0); -ELEMENTS[74794] = Fluid3D([6656,6617,5959,5948],0); -ELEMENTS[74795] = Fluid3D([8084,8792,7606,8446],0); -ELEMENTS[74796] = Fluid3D([5232,5912,6135,5619],0); -ELEMENTS[74797] = Fluid3D([4310,4781,4181,4442],0); -ELEMENTS[74798] = Fluid3D([15246,15506,15485,15109],0); -ELEMENTS[74799] = Fluid3D([9014,9761,9902,8905],0); -ELEMENTS[74800] = Fluid3D([4098,4439,4615,4805],0); -ELEMENTS[74801] = Fluid3D([7744,7429,7932,8853],0); -ELEMENTS[74802] = Fluid3D([14142,13373,13884,14452],0); -ELEMENTS[74803] = Fluid3D([4208,3838,4225,4397],0); -ELEMENTS[74804] = Fluid3D([4225,4208,4397,4886],0); -ELEMENTS[74805] = Fluid3D([11064,10587,10194,10298],0); -ELEMENTS[74806] = Fluid3D([11325,11373,10430,11087],0); -ELEMENTS[74807] = Fluid3D([14659,14243,15176,15288],0); -ELEMENTS[74808] = Fluid3D([17920,17734,17739,18073],0); -ELEMENTS[74809] = Fluid3D([15417,15795,16239,15920],0); -ELEMENTS[74810] = Fluid3D([15079,15785,15917,15496],0); -ELEMENTS[74811] = Fluid3D([15216,15630,15124,15041],0); -ELEMENTS[74812] = Fluid3D([7608,7192,6634,7376],0); -ELEMENTS[74813] = Fluid3D([5871,6030,5416,5839],0); -ELEMENTS[74814] = Fluid3D([17402,17472,17235,16818],0); -ELEMENTS[74815] = Fluid3D([5229,4834,5566,4793],0); -ELEMENTS[74816] = Fluid3D([16257,16589,16602,17055],0); -ELEMENTS[74817] = Fluid3D([4756,4467,4193,4052],0); -ELEMENTS[74818] = Fluid3D([15875,15352,15107,15860],0); -ELEMENTS[74819] = Fluid3D([12301,11614,10977,11687],0); -ELEMENTS[74820] = Fluid3D([6349,6148,5711,5369],0); -ELEMENTS[74821] = Fluid3D([2451,2381,2301,2582],0); -ELEMENTS[74822] = Fluid3D([13307,12610,13283,14116],0); -ELEMENTS[74823] = Fluid3D([7260,7604,6536,6891],0); -ELEMENTS[74824] = Fluid3D([7260,7604,6891,7117],0); -ELEMENTS[74825] = Fluid3D([6891,7260,7117,6536],0); -ELEMENTS[74826] = Fluid3D([9985,9779,9107,9206],0); -ELEMENTS[74827] = Fluid3D([9985,9779,9206,9461],0); -ELEMENTS[74828] = Fluid3D([12550,12234,12037,13190],0); -ELEMENTS[74829] = Fluid3D([15666,15642,16353,15967],0); -ELEMENTS[74830] = Fluid3D([5649,5834,5625,6350],0); -ELEMENTS[74831] = Fluid3D([9800,10471,9471,9495],0); -ELEMENTS[74832] = Fluid3D([7427,7537,7678,8370],0); -ELEMENTS[74833] = Fluid3D([7062,7629,8217,7972],0); -ELEMENTS[74834] = Fluid3D([15483,15522,14645,15096],0); -ELEMENTS[74835] = Fluid3D([10193,10421,10604,9313],0); -ELEMENTS[74836] = Fluid3D([16806,16948,17301,17149],0); -ELEMENTS[74837] = Fluid3D([16040,16233,15687,15572],0); -ELEMENTS[74838] = Fluid3D([9896,9899,10706,11367],0); -ELEMENTS[74839] = Fluid3D([2831,2788,3128,2590],0); -ELEMENTS[74840] = Fluid3D([2816,2806,2941,3191],0); -ELEMENTS[74841] = Fluid3D([18470,18565,18534,18589],0); -ELEMENTS[74842] = Fluid3D([12303,12606,13306,13688],0); -ELEMENTS[74843] = Fluid3D([18652,18657,18626,18574],0); -ELEMENTS[74844] = Fluid3D([3417,3820,3214,3430],0); -ELEMENTS[74845] = Fluid3D([3417,3820,3430,3209],0); -ELEMENTS[74846] = Fluid3D([3914,3971,3696,3316],0); -ELEMENTS[74847] = Fluid3D([11763,12568,12983,12680],0); -ELEMENTS[74848] = Fluid3D([9945,10638,10142,11164],0); -ELEMENTS[74849] = Fluid3D([15295,15052,15883,15460],0); -ELEMENTS[74850] = Fluid3D([6031,6662,5887,6166],0); -ELEMENTS[74851] = Fluid3D([8333,7333,7285,7475],0); -ELEMENTS[74852] = Fluid3D([9904,10284,11170,10889],0); -ELEMENTS[74853] = Fluid3D([2774,2817,3223,3064],0); -ELEMENTS[74854] = Fluid3D([3681,3700,3565,4296],0); -ELEMENTS[74855] = Fluid3D([18671,18675,18693,18677],0); -ELEMENTS[74856] = Fluid3D([15309,15482,15071,15924],0); -ELEMENTS[74857] = Fluid3D([17469,17221,17602,17622],0); -ELEMENTS[74858] = Fluid3D([17469,17221,17622,17616],0); -ELEMENTS[74859] = Fluid3D([5625,6229,6682,5863],0); -ELEMENTS[74860] = Fluid3D([16074,15652,15655,16077],0); -ELEMENTS[74861] = Fluid3D([3491,3326,3253,2931],0); -ELEMENTS[74862] = Fluid3D([3253,3491,2931,3458],0); -ELEMENTS[74863] = Fluid3D([12763,13036,13431,12639],0); -ELEMENTS[74864] = Fluid3D([3692,3991,3686,3813],0); -ELEMENTS[74865] = Fluid3D([6320,6114,6997,6248],0); -ELEMENTS[74866] = Fluid3D([6114,6997,6248,6661],0); -ELEMENTS[74867] = Fluid3D([11794,11206,10856,11522],0); -ELEMENTS[74868] = Fluid3D([2911,2735,3197,3037],0); -ELEMENTS[74869] = Fluid3D([8822,9001,7866,8233],0); -ELEMENTS[74870] = Fluid3D([7852,7513,7604,7117],0); -ELEMENTS[74871] = Fluid3D([6354,6363,5715,5578],0); -ELEMENTS[74872] = Fluid3D([18133,17944,18261,18236],0); -ELEMENTS[74873] = Fluid3D([2076,2273,2253,2480],0); -ELEMENTS[74874] = Fluid3D([8364,7676,7969,7252],0); -ELEMENTS[74875] = Fluid3D([8024,8379,9208,9285],0); -ELEMENTS[74876] = Fluid3D([10776,10705,9788,9899],0); -ELEMENTS[74877] = Fluid3D([9788,10776,9899,9896],0); -ELEMENTS[74878] = Fluid3D([17905,18064,17775,18123],0); -ELEMENTS[74879] = Fluid3D([5478,6152,6189,6008],0); -ELEMENTS[74880] = Fluid3D([6152,6189,6008,6738],0); -ELEMENTS[74881] = Fluid3D([4538,4730,4088,4561],0); -ELEMENTS[74882] = Fluid3D([4871,4489,4015,4131],0); -ELEMENTS[74883] = Fluid3D([9213,9475,8990,9183],0); -ELEMENTS[74884] = Fluid3D([4710,5087,4417,5107],0); -ELEMENTS[74885] = Fluid3D([6196,5626,5888,5684],0); -ELEMENTS[74886] = Fluid3D([6656,6500,7123,5948],0); -ELEMENTS[74887] = Fluid3D([9064,9090,8439,9690],0); -ELEMENTS[74888] = Fluid3D([13504,13744,14330,14444],0); -ELEMENTS[74889] = Fluid3D([4067,4225,3881,3563],0); -ELEMENTS[74890] = Fluid3D([15997,16382,16477,16634],0); -ELEMENTS[74891] = Fluid3D([7086,7072,7958,7306],0); -ELEMENTS[74892] = Fluid3D([7086,7072,7306,6315],0); -ELEMENTS[74893] = Fluid3D([7086,7072,6315,6429],0); -ELEMENTS[74894] = Fluid3D([7086,7072,6429,6909],0); -ELEMENTS[74895] = Fluid3D([6429,7086,6909,7539],0); -ELEMENTS[74896] = Fluid3D([6429,7086,7539,6462],0); -ELEMENTS[74897] = Fluid3D([6429,7086,6462,6602],0); -ELEMENTS[74898] = Fluid3D([6429,7086,6602,6315],0); -ELEMENTS[74899] = Fluid3D([6462,6429,6602,5845],0); -ELEMENTS[74900] = Fluid3D([5227,5152,4731,4469],0); -ELEMENTS[74901] = Fluid3D([13408,14360,13942,14538],0); -ELEMENTS[74902] = Fluid3D([6789,7210,6083,6224],0); -ELEMENTS[74903] = Fluid3D([16763,16603,17142,16444],0); -ELEMENTS[74904] = Fluid3D([17316,17032,17398,17542],0); -ELEMENTS[74905] = Fluid3D([16473,16079,16472,16800],0); -ELEMENTS[74906] = Fluid3D([7678,8386,7127,7558],0); -ELEMENTS[74907] = Fluid3D([4290,3852,3933,3837],0); -ELEMENTS[74908] = Fluid3D([16495,16239,16411,15795],0); -ELEMENTS[74909] = Fluid3D([17351,17075,17386,16932],0); -ELEMENTS[74910] = Fluid3D([17351,17075,16932,16975],0); -ELEMENTS[74911] = Fluid3D([7511,7347,6662,7866],0); -ELEMENTS[74912] = Fluid3D([18034,17956,18116,18301],0); -ELEMENTS[74913] = Fluid3D([5791,5400,5252,6240],0); -ELEMENTS[74914] = Fluid3D([17088,17135,17550,17696],0); -ELEMENTS[74915] = Fluid3D([9281,9336,9105,10121],0); -ELEMENTS[74916] = Fluid3D([9281,9336,10121,10561],0); -ELEMENTS[74917] = Fluid3D([8247,8721,8441,9000],0); -ELEMENTS[74918] = Fluid3D([14614,14202,14123,14980],0); -ELEMENTS[74919] = Fluid3D([17436,17696,17135,17088],0); -ELEMENTS[74920] = Fluid3D([17135,17436,17088,17167],0); -ELEMENTS[74921] = Fluid3D([9637,9875,10068,9279],0); -ELEMENTS[74922] = Fluid3D([8358,8661,7904,8460],0); -ELEMENTS[74923] = Fluid3D([17398,17365,16922,17327],0); -ELEMENTS[74924] = Fluid3D([9323,8895,8745,10086],0); -ELEMENTS[74925] = Fluid3D([9323,8895,10086,10474],0); -ELEMENTS[74926] = Fluid3D([10447,11277,9936,10850],0); -ELEMENTS[74927] = Fluid3D([9936,10447,10850,10181],0); -ELEMENTS[74928] = Fluid3D([17291,17415,17603,17768],0); -ELEMENTS[74929] = Fluid3D([4350,3669,3770,4372],0); -ELEMENTS[74930] = Fluid3D([11236,10883,12152,11768],0); -ELEMENTS[74931] = Fluid3D([6030,6432,6215,5839],0); -ELEMENTS[74932] = Fluid3D([16650,16394,17031,16667],0); -ELEMENTS[74933] = Fluid3D([16257,16824,16589,17055],0); -ELEMENTS[74934] = Fluid3D([13515,12587,12855,12418],0); -ELEMENTS[74935] = Fluid3D([5720,5310,5255,6165],0); -ELEMENTS[74936] = Fluid3D([16235,16311,15643,15876],0); -ELEMENTS[74937] = Fluid3D([17587,17473,17830,17943],0); -ELEMENTS[74938] = Fluid3D([17830,17587,17943,17747],0); -ELEMENTS[74939] = Fluid3D([17587,17473,17943,17677],0); -ELEMENTS[74940] = Fluid3D([17587,17943,17747,17731],0); -ELEMENTS[74941] = Fluid3D([13863,14564,13799,14337],0); -ELEMENTS[74942] = Fluid3D([8550,8353,9688,9517],0); -ELEMENTS[74943] = Fluid3D([15815,16035,15585,16212],0); -ELEMENTS[74944] = Fluid3D([15815,16035,16212,16579],0); -ELEMENTS[74945] = Fluid3D([16035,16212,16579,16405],0); -ELEMENTS[74946] = Fluid3D([16212,16579,16405,16441],0); -ELEMENTS[74947] = Fluid3D([16035,16212,16405,15585],0); -ELEMENTS[74948] = Fluid3D([16212,16405,15585,16441],0); -ELEMENTS[74949] = Fluid3D([16212,15815,16579,16007],0); -ELEMENTS[74950] = Fluid3D([16579,16212,16007,16441],0); -ELEMENTS[74951] = Fluid3D([16212,16007,16441,15585],0); -ELEMENTS[74952] = Fluid3D([16212,15815,16007,15585],0); -ELEMENTS[74953] = Fluid3D([4726,5299,5174,5220],0); -ELEMENTS[74954] = Fluid3D([3813,4349,3908,4300],0); -ELEMENTS[74955] = Fluid3D([4349,3908,4300,4497],0); -ELEMENTS[74956] = Fluid3D([16990,16693,16651,16457],0); -ELEMENTS[74957] = Fluid3D([8955,8453,9237,8213],0); -ELEMENTS[74958] = Fluid3D([12253,12043,11545,11424],0); -ELEMENTS[74959] = Fluid3D([2547,2843,2910,2823],0); -ELEMENTS[74960] = Fluid3D([15046,14422,14879,14445],0); -ELEMENTS[74961] = Fluid3D([16634,16916,16382,16906],0); -ELEMENTS[74962] = Fluid3D([16860,16979,17312,16894],0); -ELEMENTS[74963] = Fluid3D([14479,14794,14589,13993],0); -ELEMENTS[74964] = Fluid3D([14541,14713,14701,15463],0); -ELEMENTS[74965] = Fluid3D([2046,2170,1907,1933],0); -ELEMENTS[74966] = Fluid3D([12865,12379,13304,12405],0); -ELEMENTS[74967] = Fluid3D([5660,5981,5844,6566],0); -ELEMENTS[74968] = Fluid3D([18397,18540,18416,18539],0); -ELEMENTS[74969] = Fluid3D([9905,10686,9794,10636],0); -ELEMENTS[74970] = Fluid3D([10686,9794,10636,11038],0); -ELEMENTS[74971] = Fluid3D([18603,18571,18596,18431],0); -ELEMENTS[74972] = Fluid3D([12444,12041,12432,13310],0); -ELEMENTS[74973] = Fluid3D([15451,16080,15543,15303],0); -ELEMENTS[74974] = Fluid3D([14239,13781,14057,14853],0); -ELEMENTS[74975] = Fluid3D([4032,3955,4286,3643],0); -ELEMENTS[74976] = Fluid3D([8678,9213,9556,10263],0); -ELEMENTS[74977] = Fluid3D([9013,9923,8935,9214],0); -ELEMENTS[74978] = Fluid3D([2743,2747,3036,2804],0); -ELEMENTS[74979] = Fluid3D([15360,15306,15667,15974],0); -ELEMENTS[74980] = Fluid3D([17902,17751,18181,17989],0); -ELEMENTS[74981] = Fluid3D([12323,12836,13445,12985],0); -ELEMENTS[74982] = Fluid3D([14486,14892,13942,14360],0); -ELEMENTS[74983] = Fluid3D([8882,8379,8161,9285],0); -ELEMENTS[74984] = Fluid3D([8160,7760,7427,7599],0); -ELEMENTS[74985] = Fluid3D([17442,17131,17084,17519],0); -ELEMENTS[74986] = Fluid3D([6273,5507,5695,5562],0); -ELEMENTS[74987] = Fluid3D([15873,15790,16398,16256],0); -ELEMENTS[74988] = Fluid3D([15873,15790,16256,16257],0); -ELEMENTS[74989] = Fluid3D([16256,15873,16257,16737],0); -ELEMENTS[74990] = Fluid3D([16257,16256,16737,16358],0); -ELEMENTS[74991] = Fluid3D([16257,16256,16358,15790],0); -ELEMENTS[74992] = Fluid3D([16256,16737,16358,16398],0); -ELEMENTS[74993] = Fluid3D([16256,16358,15790,16398],0); -ELEMENTS[74994] = Fluid3D([16256,16737,16398,15873],0); -ELEMENTS[74995] = Fluid3D([16737,16257,16358,17055],0); -ELEMENTS[74996] = Fluid3D([5806,6062,6887,6618],0); -ELEMENTS[74997] = Fluid3D([15523,15985,16026,16269],0); -ELEMENTS[74998] = Fluid3D([11210,10254,11103,10207],0); -ELEMENTS[74999] = Fluid3D([15826,15483,15384,15890],0); -ELEMENTS[75000] = Fluid3D([2288,2276,2320,2568],0); -ELEMENTS[75001] = Fluid3D([10922,9692,10188,10626],0); -ELEMENTS[75002] = Fluid3D([4194,4207,3716,4031],0); -ELEMENTS[75003] = Fluid3D([12657,12064,13217,12814],0); -ELEMENTS[75004] = Fluid3D([7741,7078,7363,8115],0); -ELEMENTS[75005] = Fluid3D([3903,3691,4294,4281],0); -ELEMENTS[75006] = Fluid3D([17467,17387,17224,16848],0); -ELEMENTS[75007] = Fluid3D([17424,17675,17326,16968],0); -ELEMENTS[75008] = Fluid3D([9854,8996,9240,8595],0); -ELEMENTS[75009] = Fluid3D([14028,13267,13952,13916],0); -ELEMENTS[75010] = Fluid3D([14028,13267,13916,13360],0); -ELEMENTS[75011] = Fluid3D([13267,13916,13360,13108],0); -ELEMENTS[75012] = Fluid3D([13267,13916,13108,13952],0); -ELEMENTS[75013] = Fluid3D([10911,11259,11803,12453],0); -ELEMENTS[75014] = Fluid3D([1955,2018,1888,1972],0); -ELEMENTS[75015] = Fluid3D([8314,8822,7866,7967],0); -ELEMENTS[75016] = Fluid3D([16358,16718,17000,17055],0); -ELEMENTS[75017] = Fluid3D([7648,8132,8650,9117],0); -ELEMENTS[75018] = Fluid3D([6062,5474,5681,5355],0); -ELEMENTS[75019] = Fluid3D([12384,13040,13313,13535],0); -ELEMENTS[75020] = Fluid3D([12384,13040,13535,12783],0); -ELEMENTS[75021] = Fluid3D([13453,12646,13613,13097],0); -ELEMENTS[75022] = Fluid3D([5834,5428,5922,6639],0); -ELEMENTS[75023] = Fluid3D([5922,5834,6639,6682],0); -ELEMENTS[75024] = Fluid3D([12763,11965,12639,12478],0); -ELEMENTS[75025] = Fluid3D([18100,18155,18393,18305],0); -ELEMENTS[75026] = Fluid3D([18100,18155,18305,18097],0); -ELEMENTS[75027] = Fluid3D([13077,13393,12327,13144],0); -ELEMENTS[75028] = Fluid3D([16383,16150,16752,16814],0); -ELEMENTS[75029] = Fluid3D([5659,5589,4813,5100],0); -ELEMENTS[75030] = Fluid3D([12331,12732,13649,12254],0); -ELEMENTS[75031] = Fluid3D([7665,8438,8372,8082],0); -ELEMENTS[75032] = Fluid3D([7665,8438,8082,7856],0); -ELEMENTS[75033] = Fluid3D([8082,7665,7856,7181],0); -ELEMENTS[75034] = Fluid3D([7856,8082,7181,8507],0); -ELEMENTS[75035] = Fluid3D([7856,8082,8507,8898],0); -ELEMENTS[75036] = Fluid3D([8438,8082,7856,8898],0); -ELEMENTS[75037] = Fluid3D([8438,8082,8898,8507],0); -ELEMENTS[75038] = Fluid3D([8438,8082,8507,8372],0); -ELEMENTS[75039] = Fluid3D([8082,8507,8372,7181],0); -ELEMENTS[75040] = Fluid3D([4061,3760,3555,3546],0); -ELEMENTS[75041] = Fluid3D([9090,8223,8439,7778],0); -ELEMENTS[75042] = Fluid3D([16333,16290,15761,16416],0); -ELEMENTS[75043] = Fluid3D([11966,12932,11769,12635],0); -ELEMENTS[75044] = Fluid3D([16805,16638,17045,17224],0); -ELEMENTS[75045] = Fluid3D([7781,8797,8074,7795],0); -ELEMENTS[75046] = Fluid3D([14358,14039,13985,14946],0); -ELEMENTS[75047] = Fluid3D([5421,5541,6233,5663],0); -ELEMENTS[75048] = Fluid3D([2432,2638,2537,2260],0); -ELEMENTS[75049] = Fluid3D([6294,6608,6073,7126],0); -ELEMENTS[75050] = Fluid3D([8759,8106,8076,8756],0); -ELEMENTS[75051] = Fluid3D([12187,12859,12080,13302],0); -ELEMENTS[75052] = Fluid3D([2705,2986,2854,3215],0); -ELEMENTS[75053] = Fluid3D([8291,8947,8283,7712],0); -ELEMENTS[75054] = Fluid3D([8947,8283,7712,8475],0); -ELEMENTS[75055] = Fluid3D([8283,7712,8475,7908],0); -ELEMENTS[75056] = Fluid3D([8283,7712,7908,8132],0); -ELEMENTS[75057] = Fluid3D([8947,8283,8475,9120],0); -ELEMENTS[75058] = Fluid3D([8283,7712,8132,7629],0); -ELEMENTS[75059] = Fluid3D([8283,7712,7629,8291],0); -ELEMENTS[75060] = Fluid3D([12635,12224,13554,13051],0); -ELEMENTS[75061] = Fluid3D([13770,13071,14210,13434],0); -ELEMENTS[75062] = Fluid3D([2970,2849,2800,2994],0); -ELEMENTS[75063] = Fluid3D([11109,11421,12065,11220],0); -ELEMENTS[75064] = Fluid3D([10086,9848,8895,8745],0); -ELEMENTS[75065] = Fluid3D([13001,13277,13433,14105],0); -ELEMENTS[75066] = Fluid3D([12986,12987,12845,11692],0); -ELEMENTS[75067] = Fluid3D([5453,5410,5661,6297],0); -ELEMENTS[75068] = Fluid3D([3737,3778,3562,4150],0); -ELEMENTS[75069] = Fluid3D([10005,9748,9329,10200],0); -ELEMENTS[75070] = Fluid3D([9661,9908,9089,8907],0); -ELEMENTS[75071] = Fluid3D([15741,15466,15498,16244],0); -ELEMENTS[75072] = Fluid3D([18431,18529,18444,18596],0); -ELEMENTS[75073] = Fluid3D([18431,18529,18596,18603],0); -ELEMENTS[75074] = Fluid3D([13511,14255,14286,13619],0); -ELEMENTS[75075] = Fluid3D([14255,14286,13619,14319],0); -ELEMENTS[75076] = Fluid3D([8152,8722,8912,8414],0); -ELEMENTS[75077] = Fluid3D([11698,10883,10637,11768],0); -ELEMENTS[75078] = Fluid3D([11698,10883,11768,12152],0); -ELEMENTS[75079] = Fluid3D([15991,15794,16481,16379],0); -ELEMENTS[75080] = Fluid3D([16606,16145,16526,16254],0); -ELEMENTS[75081] = Fluid3D([4734,4745,5150,5574],0); -ELEMENTS[75082] = Fluid3D([5852,6193,5489,5848],0); -ELEMENTS[75083] = Fluid3D([15920,16224,15573,16076],0); -ELEMENTS[75084] = Fluid3D([15910,15537,15254,15062],0); -ELEMENTS[75085] = Fluid3D([8531,9487,9104,9029],0); -ELEMENTS[75086] = Fluid3D([5548,5569,4825,5222],0); -ELEMENTS[75087] = Fluid3D([5311,5370,5771,5524],0); -ELEMENTS[75088] = Fluid3D([12722,13209,13452,12370],0); -ELEMENTS[75089] = Fluid3D([6298,6516,5704,5592],0); -ELEMENTS[75090] = Fluid3D([4884,4849,5605,4835],0); -ELEMENTS[75091] = Fluid3D([2914,3149,3246,2714],0); -ELEMENTS[75092] = Fluid3D([6835,7243,6190,7372],0); -ELEMENTS[75093] = Fluid3D([6229,6555,5848,6061],0); -ELEMENTS[75094] = Fluid3D([6229,6555,6061,7231],0); -ELEMENTS[75095] = Fluid3D([7925,7618,8217,8639],0); -ELEMENTS[75096] = Fluid3D([4710,4122,4822,4357],0); -ELEMENTS[75097] = Fluid3D([16644,17032,16986,17365],0); -ELEMENTS[75098] = Fluid3D([14020,13694,13533,14386],0); -ELEMENTS[75099] = Fluid3D([9258,9205,10018,8861],0); -ELEMENTS[75100] = Fluid3D([10529,10290,9396,10104],0); -ELEMENTS[75101] = Fluid3D([6679,7644,7622,6900],0); -ELEMENTS[75102] = Fluid3D([15641,15292,15034,14607],0); -ELEMENTS[75103] = Fluid3D([3989,3907,3586,3403],0); -ELEMENTS[75104] = Fluid3D([14070,13625,13743,13077],0); -ELEMENTS[75105] = Fluid3D([10437,10316,9310,9139],0); -ELEMENTS[75106] = Fluid3D([5158,4699,4386,4861],0); -ELEMENTS[75107] = Fluid3D([10037,10191,9618,8884],0); -ELEMENTS[75108] = Fluid3D([6005,5742,5195,5471],0); -ELEMENTS[75109] = Fluid3D([6005,5742,5471,5952],0); -ELEMENTS[75110] = Fluid3D([5471,6005,5952,5535],0); -ELEMENTS[75111] = Fluid3D([5471,6005,5535,5195],0); -ELEMENTS[75112] = Fluid3D([5952,5471,5535,5508],0); -ELEMENTS[75113] = Fluid3D([5952,5471,5508,5099],0); -ELEMENTS[75114] = Fluid3D([5952,5471,5099,5742],0); -ELEMENTS[75115] = Fluid3D([5742,5195,5471,5099],0); -ELEMENTS[75116] = Fluid3D([5471,5508,5099,5535],0); -ELEMENTS[75117] = Fluid3D([5535,5471,5195,5099],0); -ELEMENTS[75118] = Fluid3D([17350,17578,17338,17017],0); -ELEMENTS[75119] = Fluid3D([2385,2288,2109,2263],0); -ELEMENTS[75120] = Fluid3D([5752,6066,6553,6669],0); -ELEMENTS[75121] = Fluid3D([8735,8043,8288,8447],0); -ELEMENTS[75122] = Fluid3D([16598,16948,16819,16303],0); -ELEMENTS[75123] = Fluid3D([16819,16598,16303,16057],0); -ELEMENTS[75124] = Fluid3D([4459,4449,4983,4641],0); -ELEMENTS[75125] = Fluid3D([14394,13590,13981,13328],0); -ELEMENTS[75126] = Fluid3D([3770,4350,4372,4125],0); -ELEMENTS[75127] = Fluid3D([13962,14243,13615,14838],0); -ELEMENTS[75128] = Fluid3D([15254,15062,15326,15728],0); -ELEMENTS[75129] = Fluid3D([9872,10822,10795,9720],0); -ELEMENTS[75130] = Fluid3D([9259,8764,9708,9901],0); -ELEMENTS[75131] = Fluid3D([17430,17573,17138,17452],0); -ELEMENTS[75132] = Fluid3D([17776,17326,17548,17675],0); -ELEMENTS[75133] = Fluid3D([5907,5373,5843,6247],0); -ELEMENTS[75134] = Fluid3D([17589,17629,17505,17041],0); -ELEMENTS[75135] = Fluid3D([15865,16040,15267,15572],0); -ELEMENTS[75136] = Fluid3D([16694,17029,17077,16754],0); -ELEMENTS[75137] = Fluid3D([7236,7918,8294,7446],0); -ELEMENTS[75138] = Fluid3D([11307,12044,11161,10581],0); -ELEMENTS[75139] = Fluid3D([3182,3414,3327,3730],0); -ELEMENTS[75140] = Fluid3D([3182,3414,3730,3797],0); -ELEMENTS[75141] = Fluid3D([6568,5953,6611,5828],0); -ELEMENTS[75142] = Fluid3D([15049,15305,14657,15261],0); -ELEMENTS[75143] = Fluid3D([4821,5129,4556,4482],0); -ELEMENTS[75144] = Fluid3D([9903,10218,9456,9045],0); -ELEMENTS[75145] = Fluid3D([12167,12110,12665,13309],0); -ELEMENTS[75146] = Fluid3D([16719,16750,16717,17313],0); -ELEMENTS[75147] = Fluid3D([3430,3417,3209,3214],0); -ELEMENTS[75148] = Fluid3D([3209,3430,3214,2888],0); -ELEMENTS[75149] = Fluid3D([8372,7665,8082,7181],0); -ELEMENTS[75150] = Fluid3D([16454,16199,16275,15673],0); -ELEMENTS[75151] = Fluid3D([15846,16346,16067,16458],0); -ELEMENTS[75152] = Fluid3D([6360,6160,5744,6912],0); -ELEMENTS[75153] = Fluid3D([10027,10520,10775,10867],0); -ELEMENTS[75154] = Fluid3D([6985,6337,6755,7041],0); -ELEMENTS[75155] = Fluid3D([6985,6337,7041,7316],0); -ELEMENTS[75156] = Fluid3D([4479,3967,4430,4372],0); -ELEMENTS[75157] = Fluid3D([14278,14119,13434,13768],0); -ELEMENTS[75158] = Fluid3D([14956,15184,15223,14839],0); -ELEMENTS[75159] = Fluid3D([15184,15223,14839,15892],0); -ELEMENTS[75160] = Fluid3D([2583,2535,2453,2241],0); -ELEMENTS[75161] = Fluid3D([15435,15795,15573,16076],0); -ELEMENTS[75162] = Fluid3D([15435,15795,16076,16156],0); -ELEMENTS[75163] = Fluid3D([15573,15435,16076,15602],0); -ELEMENTS[75164] = Fluid3D([15795,15573,16076,15920],0); -ELEMENTS[75165] = Fluid3D([10811,9969,10009,9853],0); -ELEMENTS[75166] = Fluid3D([2854,3043,2705,3215],0); -ELEMENTS[75167] = Fluid3D([18475,18344,18543,18448],0); -ELEMENTS[75168] = Fluid3D([12002,12087,11272,11033],0); -ELEMENTS[75169] = Fluid3D([16026,15523,16269,15295],0); -ELEMENTS[75170] = Fluid3D([6255,6801,6118,7146],0); -ELEMENTS[75171] = Fluid3D([18601,18526,18550,18646],0); -ELEMENTS[75172] = Fluid3D([8622,8075,7731,9051],0); -ELEMENTS[75173] = Fluid3D([4308,4357,4092,4922],0); -ELEMENTS[75174] = Fluid3D([17463,17529,17916,17742],0); -ELEMENTS[75175] = Fluid3D([3434,3329,3530,3984],0); -ELEMENTS[75176] = Fluid3D([14514,15068,13866,14279],0); -ELEMENTS[75177] = Fluid3D([17138,16674,16535,16985],0); -ELEMENTS[75178] = Fluid3D([9692,10922,10036,10626],0); -ELEMENTS[75179] = Fluid3D([17456,17291,17148,17373],0); -ELEMENTS[75180] = Fluid3D([7364,6566,6835,6721],0); -ELEMENTS[75181] = Fluid3D([10580,9363,9993,9801],0); -ELEMENTS[75182] = Fluid3D([15713,15881,15275,15838],0); -ELEMENTS[75183] = Fluid3D([14141,13992,13428,13053],0); -ELEMENTS[75184] = Fluid3D([16082,15538,16016,16459],0); -ELEMENTS[75185] = Fluid3D([14419,14514,15372,14928],0); -ELEMENTS[75186] = Fluid3D([13725,14235,13843,13458],0); -ELEMENTS[75187] = Fluid3D([4691,5269,5155,4791],0); -ELEMENTS[75188] = Fluid3D([15509,15582,15749,16306],0); -ELEMENTS[75189] = Fluid3D([2947,2980,2620,2823],0); -ELEMENTS[75190] = Fluid3D([2010,2002,2152,2200],0); -ELEMENTS[75191] = Fluid3D([2002,2152,2200,1932],0); -ELEMENTS[75192] = Fluid3D([7820,8593,8479,7640],0); -ELEMENTS[75193] = Fluid3D([8593,8479,7640,7672],0); -ELEMENTS[75194] = Fluid3D([9108,9969,9853,10009],0); -ELEMENTS[75195] = Fluid3D([3267,3446,3273,3013],0); -ELEMENTS[75196] = Fluid3D([6262,5757,6116,6690],0); -ELEMENTS[75197] = Fluid3D([6116,6262,6690,6982],0); -ELEMENTS[75198] = Fluid3D([9785,9413,9260,8635],0); -ELEMENTS[75199] = Fluid3D([13147,14020,13533,13722],0); -ELEMENTS[75200] = Fluid3D([10937,10810,10882,11973],0); -ELEMENTS[75201] = Fluid3D([12357,12610,11619,12399],0); -ELEMENTS[75202] = Fluid3D([5666,6113,6156,6718],0); -ELEMENTS[75203] = Fluid3D([5666,6113,6718,5985],0); -ELEMENTS[75204] = Fluid3D([5757,5750,6013,6645],0); -ELEMENTS[75205] = Fluid3D([12040,11048,11755,10820],0); -ELEMENTS[75206] = Fluid3D([3431,3327,3916,3730],0); -ELEMENTS[75207] = Fluid3D([2738,2476,2667,2844],0); -ELEMENTS[75208] = Fluid3D([13926,13198,13153,14237],0); -ELEMENTS[75209] = Fluid3D([10224,10350,9173,9521],0); -ELEMENTS[75210] = Fluid3D([15675,16291,16460,16005],0); -ELEMENTS[75211] = Fluid3D([6006,6138,6100,5645],0); -ELEMENTS[75212] = Fluid3D([6138,6100,5645,6206],0); -ELEMENTS[75213] = Fluid3D([4872,5021,4500,4266],0); -ELEMENTS[75214] = Fluid3D([11899,12015,11475,12432],0); -ELEMENTS[75215] = Fluid3D([7731,8075,7015,7493],0); -ELEMENTS[75216] = Fluid3D([7015,7731,7493,6875],0); -ELEMENTS[75217] = Fluid3D([10651,9917,9285,10548],0); -ELEMENTS[75218] = Fluid3D([5883,5506,6341,6156],0); -ELEMENTS[75219] = Fluid3D([5765,6366,5897,5515],0); -ELEMENTS[75220] = Fluid3D([2288,2186,2109,1964],0); -ELEMENTS[75221] = Fluid3D([16309,16500,16736,16974],0); -ELEMENTS[75222] = Fluid3D([8105,7314,7051,7623],0); -ELEMENTS[75223] = Fluid3D([13058,12978,13702,13907],0); -ELEMENTS[75224] = Fluid3D([17432,17244,17671,17747],0); -ELEMENTS[75225] = Fluid3D([18185,18334,18439,18483],0); -ELEMENTS[75226] = Fluid3D([14309,14576,15057,15114],0); -ELEMENTS[75227] = Fluid3D([16770,16464,16796,16350],0); -ELEMENTS[75228] = Fluid3D([16464,16796,16350,16164],0); -ELEMENTS[75229] = Fluid3D([16796,16350,16164,16564],0); -ELEMENTS[75230] = Fluid3D([16796,16350,16564,16882],0); -ELEMENTS[75231] = Fluid3D([12585,12040,13320,12633],0); -ELEMENTS[75232] = Fluid3D([14837,15199,14722,14873],0); -ELEMENTS[75233] = Fluid3D([14751,15361,14906,14231],0); -ELEMENTS[75234] = Fluid3D([11022,9619,10414,10587],0); -ELEMENTS[75235] = Fluid3D([17944,17977,18261,18236],0); -ELEMENTS[75236] = Fluid3D([13374,13876,12647,12979],0); -ELEMENTS[75237] = Fluid3D([12647,13374,12979,12504],0); -ELEMENTS[75238] = Fluid3D([4133,4555,4279,4441],0); -ELEMENTS[75239] = Fluid3D([4133,4555,4441,4854],0); -ELEMENTS[75240] = Fluid3D([4919,5070,5520,5882],0); -ELEMENTS[75241] = Fluid3D([15844,15483,15890,15504],0); -ELEMENTS[75242] = Fluid3D([2727,2948,2611,2498],0); -ELEMENTS[75243] = Fluid3D([12675,13489,12524,12020],0); -ELEMENTS[75244] = Fluid3D([15047,14462,15537,14465],0); -ELEMENTS[75245] = Fluid3D([9962,9560,10928,9985],0); -ELEMENTS[75246] = Fluid3D([16073,16341,15827,15801],0); -ELEMENTS[75247] = Fluid3D([8194,7376,8165,7461],0); -ELEMENTS[75248] = Fluid3D([15654,15239,16154,16083],0); -ELEMENTS[75249] = Fluid3D([14657,14414,15261,15305],0); -ELEMENTS[75250] = Fluid3D([15463,15234,14701,14541],0); -ELEMENTS[75251] = Fluid3D([14348,13768,14226,14437],0); -ELEMENTS[75252] = Fluid3D([16159,16178,16727,16868],0); -ELEMENTS[75253] = Fluid3D([15879,16262,15902,16230],0); -ELEMENTS[75254] = Fluid3D([15229,14456,15133,14552],0); -ELEMENTS[75255] = Fluid3D([12323,12678,13445,13175],0); -ELEMENTS[75256] = Fluid3D([16897,16825,16865,17333],0); -ELEMENTS[75257] = Fluid3D([16873,16842,17085,16691],0); -ELEMENTS[75258] = Fluid3D([3187,2963,2859,3157],0); -ELEMENTS[75259] = Fluid3D([2403,2401,2130,2232],0); -ELEMENTS[75260] = Fluid3D([9444,10181,8908,8452],0); -ELEMENTS[75261] = Fluid3D([3450,3262,2994,3490],0); -ELEMENTS[75262] = Fluid3D([11972,12699,12065,11306],0); -ELEMENTS[75263] = Fluid3D([3527,3603,3919,3818],0); -ELEMENTS[75264] = Fluid3D([7648,8289,7882,8607],0); -ELEMENTS[75265] = Fluid3D([18370,18452,18412,18553],0); -ELEMENTS[75266] = Fluid3D([7074,7823,8074,7781],0); -ELEMENTS[75267] = Fluid3D([6338,6266,5834,6639],0); -ELEMENTS[75268] = Fluid3D([3267,2886,3040,2944],0); -ELEMENTS[75269] = Fluid3D([13670,13709,14476,14649],0); -ELEMENTS[75270] = Fluid3D([8202,9109,8353,8819],0); -ELEMENTS[75271] = Fluid3D([13211,12962,12255,11946],0); -ELEMENTS[75272] = Fluid3D([17364,17701,17305,17269],0); -ELEMENTS[75273] = Fluid3D([3746,4091,4389,3839],0); -ELEMENTS[75274] = Fluid3D([7198,6824,6465,6162],0); -ELEMENTS[75275] = Fluid3D([14382,14984,15335,14676],0); -ELEMENTS[75276] = Fluid3D([6916,6339,6179,6887],0); -ELEMENTS[75277] = Fluid3D([15939,15933,16362,15801],0); -ELEMENTS[75278] = Fluid3D([12281,12885,12362,11980],0); -ELEMENTS[75279] = Fluid3D([12281,12885,11980,12107],0); -ELEMENTS[75280] = Fluid3D([12885,12362,11980,11719],0); -ELEMENTS[75281] = Fluid3D([11980,12885,11719,12107],0); -ELEMENTS[75282] = Fluid3D([11719,11980,12107,11470],0); -ELEMENTS[75283] = Fluid3D([11719,11980,11470,12362],0); -ELEMENTS[75284] = Fluid3D([11980,11470,12362,12281],0); -ELEMENTS[75285] = Fluid3D([11980,11470,12281,12107],0); -ELEMENTS[75286] = Fluid3D([10889,11669,10558,11362],0); -ELEMENTS[75287] = Fluid3D([2524,2476,2844,2542],0); -ELEMENTS[75288] = Fluid3D([17576,17463,17742,17033],0); -ELEMENTS[75289] = Fluid3D([13812,14525,15090,14715],0); -ELEMENTS[75290] = Fluid3D([14525,15090,14715,14854],0); -ELEMENTS[75291] = Fluid3D([6868,6264,6984,6615],0); -ELEMENTS[75292] = Fluid3D([16018,16443,15907,15826],0); -ELEMENTS[75293] = Fluid3D([9935,11095,10553,10552],0); -ELEMENTS[75294] = Fluid3D([18401,18368,18453,18518],0); -ELEMENTS[75295] = Fluid3D([11972,11257,12218,11306],0); -ELEMENTS[75296] = Fluid3D([12016,10831,11423,11447],0); -ELEMENTS[75297] = Fluid3D([11698,11855,11173,12152],0); -ELEMENTS[75298] = Fluid3D([13333,13103,12484,13612],0); -ELEMENTS[75299] = Fluid3D([13333,13103,13612,13989],0); -ELEMENTS[75300] = Fluid3D([9786,8646,8675,8614],0); -ELEMENTS[75301] = Fluid3D([7269,7585,8031,8583],0); -ELEMENTS[75302] = Fluid3D([11824,11795,12240,11298],0); -ELEMENTS[75303] = Fluid3D([15216,14641,15622,15403],0); -ELEMENTS[75304] = Fluid3D([9090,9457,9139,10304],0); -ELEMENTS[75305] = Fluid3D([11717,11641,11901,10829],0); -ELEMENTS[75306] = Fluid3D([11447,12016,12714,12057],0); -ELEMENTS[75307] = Fluid3D([8270,8569,7893,7478],0); -ELEMENTS[75308] = Fluid3D([10337,10308,11492,11358],0); -ELEMENTS[75309] = Fluid3D([4610,4286,3834,4101],0); -ELEMENTS[75310] = Fluid3D([7613,7250,7193,6332],0); -ELEMENTS[75311] = Fluid3D([10243,10688,11608,11186],0); -ELEMENTS[75312] = Fluid3D([6294,7126,6802,6608],0); -ELEMENTS[75313] = Fluid3D([11634,11041,12193,11237],0); -ELEMENTS[75314] = Fluid3D([5323,5953,5864,5828],0); -ELEMENTS[75315] = Fluid3D([17666,17591,17990,17816],0); -ELEMENTS[75316] = Fluid3D([3331,3175,2981,3300],0); -ELEMENTS[75317] = Fluid3D([16207,16268,15563,16066],0); -ELEMENTS[75318] = Fluid3D([8499,7585,8519,8583],0); -ELEMENTS[75319] = Fluid3D([16856,17008,16837,17270],0); -ELEMENTS[75320] = Fluid3D([2152,2009,2200,1932],0); -ELEMENTS[75321] = Fluid3D([10428,9745,9225,10676],0); -ELEMENTS[75322] = Fluid3D([5046,5490,4924,4715],0); -ELEMENTS[75323] = Fluid3D([3386,3236,3191,2806],0); -ELEMENTS[75324] = Fluid3D([15097,15586,14849,14564],0); -ELEMENTS[75325] = Fluid3D([8728,9703,8755,9375],0); -ELEMENTS[75326] = Fluid3D([10270,9917,10737,11405],0); -ELEMENTS[75327] = Fluid3D([10737,10270,11405,11390],0); -ELEMENTS[75328] = Fluid3D([3525,3321,3734,4016],0); -ELEMENTS[75329] = Fluid3D([9115,9971,9514,9576],0); -ELEMENTS[75330] = Fluid3D([9115,9971,9576,10098],0); -ELEMENTS[75331] = Fluid3D([16307,16158,16051,16593],0); -ELEMENTS[75332] = Fluid3D([13778,13779,12813,13872],0); -ELEMENTS[75333] = Fluid3D([8272,8610,8367,9257],0); -ELEMENTS[75334] = Fluid3D([4231,4817,4755,4384],0); -ELEMENTS[75335] = Fluid3D([15654,15320,15934,16158],0); -ELEMENTS[75336] = Fluid3D([15795,15758,16411,16156],0); -ELEMENTS[75337] = Fluid3D([10572,9703,10795,10289],0); -ELEMENTS[75338] = Fluid3D([18075,17868,17863,17895],0); -ELEMENTS[75339] = Fluid3D([7146,7594,7274,6801],0); -ELEMENTS[75340] = Fluid3D([7874,8433,7825,7663],0); -ELEMENTS[75341] = Fluid3D([14138,14133,13810,14904],0); -ELEMENTS[75342] = Fluid3D([13057,13804,14021,14449],0); -ELEMENTS[75343] = Fluid3D([14462,14465,14322,15254],0); -ELEMENTS[75344] = Fluid3D([15608,15460,14840,15295],0); -ELEMENTS[75345] = Fluid3D([9887,9051,9696,10540],0); -ELEMENTS[75346] = Fluid3D([4031,4147,4552,4207],0); -ELEMENTS[75347] = Fluid3D([4147,4552,4207,4591],0); -ELEMENTS[75348] = Fluid3D([3077,3073,2772,2969],0); -ELEMENTS[75349] = Fluid3D([3666,4126,3673,3752],0); -ELEMENTS[75350] = Fluid3D([3666,4126,3752,3550],0); -ELEMENTS[75351] = Fluid3D([4837,5372,5645,5322],0); -ELEMENTS[75352] = Fluid3D([5695,5507,4949,5562],0); -ELEMENTS[75353] = Fluid3D([17592,17719,17701,17269],0); -ELEMENTS[75354] = Fluid3D([12108,12916,12453,12172],0); -ELEMENTS[75355] = Fluid3D([17613,17565,17180,17060],0); -ELEMENTS[75356] = Fluid3D([16593,16374,16784,16829],0); -ELEMENTS[75357] = Fluid3D([16593,16374,16829,17010],0); -ELEMENTS[75358] = Fluid3D([11718,11676,11896,11004],0); -ELEMENTS[75359] = Fluid3D([12494,12918,11932,11498],0); -ELEMENTS[75360] = Fluid3D([17043,16916,16906,16382],0); -ELEMENTS[75361] = Fluid3D([11993,10893,11515,11763],0); -ELEMENTS[75362] = Fluid3D([13637,13775,13783,12809],0); -ELEMENTS[75363] = Fluid3D([5419,5943,6406,5556],0); -ELEMENTS[75364] = Fluid3D([6090,6091,5848,6965],0); -ELEMENTS[75365] = Fluid3D([17969,18010,18255,18073],0); -ELEMENTS[75366] = Fluid3D([7362,7231,7544,6350],0); -ELEMENTS[75367] = Fluid3D([9434,8699,8832,8151],0); -ELEMENTS[75368] = Fluid3D([18497,18486,18467,18559],0); -ELEMENTS[75369] = Fluid3D([16178,16512,16727,16868],0); -ELEMENTS[75370] = Fluid3D([8143,8166,7213,7566],0); -ELEMENTS[75371] = Fluid3D([16023,15992,16358,15502],0); -ELEMENTS[75372] = Fluid3D([5463,5130,4666,5100],0); -ELEMENTS[75373] = Fluid3D([16294,16426,16858,16500],0); -ELEMENTS[75374] = Fluid3D([3652,3768,4025,4337],0); -ELEMENTS[75375] = Fluid3D([3874,4160,3528,4143],0); -ELEMENTS[75376] = Fluid3D([14028,14745,14459,13952],0); -ELEMENTS[75377] = Fluid3D([4117,4637,4132,4620],0); -ELEMENTS[75378] = Fluid3D([12129,11397,12149,12531],0); -ELEMENTS[75379] = Fluid3D([10156,9126,9583,9961],0); -ELEMENTS[75380] = Fluid3D([16114,16293,16006,15461],0); -ELEMENTS[75381] = Fluid3D([16006,16114,15461,15441],0); -ELEMENTS[75382] = Fluid3D([14596,13693,13578,13999],0); -ELEMENTS[75383] = Fluid3D([4215,3811,4120,4434],0); -ELEMENTS[75384] = Fluid3D([4215,3811,4434,3993],0); -ELEMENTS[75385] = Fluid3D([3811,4434,3993,4120],0); -ELEMENTS[75386] = Fluid3D([4434,3993,4120,3847],0); -ELEMENTS[75387] = Fluid3D([16058,15818,16161,15732],0); -ELEMENTS[75388] = Fluid3D([2480,2279,2166,2076],0); -ELEMENTS[75389] = Fluid3D([3755,3358,3828,4007],0); -ELEMENTS[75390] = Fluid3D([16462,16813,16237,16133],0); -ELEMENTS[75391] = Fluid3D([2854,2641,2381,2835],0); -ELEMENTS[75392] = Fluid3D([2854,2641,2835,3037],0); -ELEMENTS[75393] = Fluid3D([2641,2835,3037,2735],0); -ELEMENTS[75394] = Fluid3D([2641,2835,2735,2451],0); -ELEMENTS[75395] = Fluid3D([2641,2835,2451,2381],0); -ELEMENTS[75396] = Fluid3D([2451,2641,2381,2582],0); -ELEMENTS[75397] = Fluid3D([17752,17794,17587,17943],0); -ELEMENTS[75398] = Fluid3D([17794,17587,17943,17540],0); -ELEMENTS[75399] = Fluid3D([17644,17234,17630,17571],0); -ELEMENTS[75400] = Fluid3D([11445,11582,10357,11168],0); -ELEMENTS[75401] = Fluid3D([5130,5463,5143,5100],0); -ELEMENTS[75402] = Fluid3D([13390,14126,14246,14023],0); -ELEMENTS[75403] = Fluid3D([12601,12293,13132,13650],0); -ELEMENTS[75404] = Fluid3D([10562,9775,11273,10577],0); -ELEMENTS[75405] = Fluid3D([15164,15320,15116,14397],0); -ELEMENTS[75406] = Fluid3D([2318,2118,2122,2006],0); -ELEMENTS[75407] = Fluid3D([17877,17949,18052,18247],0); -ELEMENTS[75408] = Fluid3D([10299,10225,11194,11667],0); -ELEMENTS[75409] = Fluid3D([5615,6082,5769,6251],0); -ELEMENTS[75410] = Fluid3D([18245,17959,18196,18227],0); -ELEMENTS[75411] = Fluid3D([13871,13203,13529,12837],0); -ELEMENTS[75412] = Fluid3D([8773,8556,9387,8792],0); -ELEMENTS[75413] = Fluid3D([7657,7871,8863,8265],0); -ELEMENTS[75414] = Fluid3D([14267,13732,13615,14522],0); -ELEMENTS[75415] = Fluid3D([4394,4442,4310,3780],0); -ELEMENTS[75416] = Fluid3D([2743,2578,2350,2468],0); -ELEMENTS[75417] = Fluid3D([12855,11808,11889,12583],0); -ELEMENTS[75418] = Fluid3D([7368,7984,6772,7870],0); -ELEMENTS[75419] = Fluid3D([12306,12323,11816,12985],0); -ELEMENTS[75420] = Fluid3D([17109,17098,17367,17023],0); -ELEMENTS[75421] = Fluid3D([13989,13612,13366,13103],0); -ELEMENTS[75422] = Fluid3D([3226,3604,3310,3881],0); -ELEMENTS[75423] = Fluid3D([13510,13339,12859,12717],0); -ELEMENTS[75424] = Fluid3D([3752,4190,4173,4485],0); -ELEMENTS[75425] = Fluid3D([18192,18241,18132,18332],0); -ELEMENTS[75426] = Fluid3D([3223,3420,3351,3873],0); -ELEMENTS[75427] = Fluid3D([15354,15553,16175,16122],0); -ELEMENTS[75428] = Fluid3D([5858,6120,5994,6768],0); -ELEMENTS[75429] = Fluid3D([16155,15503,16306,16213],0); -ELEMENTS[75430] = Fluid3D([11900,10959,12215,11623],0); -ELEMENTS[75431] = Fluid3D([14703,15409,15149,14865],0); -ELEMENTS[75432] = Fluid3D([14703,15409,14865,15659],0); -ELEMENTS[75433] = Fluid3D([6873,6748,7299,6396],0); -ELEMENTS[75434] = Fluid3D([9910,10218,9045,9456],0); -ELEMENTS[75435] = Fluid3D([7072,7035,6909,7602],0); -ELEMENTS[75436] = Fluid3D([2568,2680,2425,2263],0); -ELEMENTS[75437] = Fluid3D([2425,2568,2263,2320],0); -ELEMENTS[75438] = Fluid3D([6133,6803,5984,5812],0); -ELEMENTS[75439] = Fluid3D([16747,17072,16749,16303],0); -ELEMENTS[75440] = Fluid3D([16747,17072,16303,16948],0); -ELEMENTS[75441] = Fluid3D([12604,12800,12399,11619],0); -ELEMENTS[75442] = Fluid3D([6802,7711,7747,7126],0); -ELEMENTS[75443] = Fluid3D([3788,3375,3882,3748],0); -ELEMENTS[75444] = Fluid3D([18657,18676,18647,18660],0); -ELEMENTS[75445] = Fluid3D([18461,18556,18466,18471],0); -ELEMENTS[75446] = Fluid3D([18461,18556,18471,18462],0); -ELEMENTS[75447] = Fluid3D([18461,18556,18462,18554],0); -ELEMENTS[75448] = Fluid3D([18556,18462,18554,18456],0); -ELEMENTS[75449] = Fluid3D([18462,18554,18456,18455],0); -ELEMENTS[75450] = Fluid3D([18462,18554,18455,18461],0); -ELEMENTS[75451] = Fluid3D([18556,18471,18462,18456],0); -ELEMENTS[75452] = Fluid3D([18455,18462,18461,18327],0); -ELEMENTS[75453] = Fluid3D([18456,18462,18455,18327],0); -ELEMENTS[75454] = Fluid3D([18456,18462,18327,18471],0); -ELEMENTS[75455] = Fluid3D([18462,18327,18471,18461],0); -ELEMENTS[75456] = Fluid3D([4393,4225,4773,4886],0); -ELEMENTS[75457] = Fluid3D([11142,10127,10626,10188],0); -ELEMENTS[75458] = Fluid3D([6662,6736,6166,6600],0); -ELEMENTS[75459] = Fluid3D([6662,6736,6600,7200],0); -ELEMENTS[75460] = Fluid3D([6600,6662,7200,7777],0); -ELEMENTS[75461] = Fluid3D([13353,13250,14117,14446],0); -ELEMENTS[75462] = Fluid3D([3682,4281,4025,3837],0); -ELEMENTS[75463] = Fluid3D([18571,18525,18414,18431],0); -ELEMENTS[75464] = Fluid3D([9323,10432,10474,10479],0); -ELEMENTS[75465] = Fluid3D([6467,6715,7780,7771],0); -ELEMENTS[75466] = Fluid3D([18482,18563,18476,18419],0); -ELEMENTS[75467] = Fluid3D([16687,16382,17043,16716],0); -ELEMENTS[75468] = Fluid3D([5576,5403,5205,6111],0); -ELEMENTS[75469] = Fluid3D([9943,9806,8897,9622],0); -ELEMENTS[75470] = Fluid3D([10812,10571,11647,10873],0); -ELEMENTS[75471] = Fluid3D([11786,12248,11647,10873],0); -ELEMENTS[75472] = Fluid3D([10786,10557,11969,10571],0); -ELEMENTS[75473] = Fluid3D([12262,11786,12164,11314],0); -ELEMENTS[75474] = Fluid3D([10873,10266,9622,10557],0); -ELEMENTS[75475] = Fluid3D([10726,10185,10786,11537],0); -ELEMENTS[75476] = Fluid3D([9806,9995,9420,10557],0); -ELEMENTS[75477] = Fluid3D([11314,11632,12164,11995],0); -ELEMENTS[75478] = Fluid3D([11540,11314,12164,11969],0); -ELEMENTS[75479] = Fluid3D([9806,9420,8897,9622],0); -ELEMENTS[75480] = Fluid3D([10571,9998,11146,10786],0); -ELEMENTS[75481] = Fluid3D([9622,9420,9672,10557],0); -ELEMENTS[75482] = Fluid3D([10571,9672,9998,10557],0); -ELEMENTS[75483] = Fluid3D([9640,9672,10571,10873],0); -ELEMENTS[75484] = Fluid3D([10266,9622,10557,9806],0); -ELEMENTS[75485] = Fluid3D([10266,9622,9806,9943],0); -ELEMENTS[75486] = Fluid3D([12164,12262,11314,12034],0); -ELEMENTS[75487] = Fluid3D([9672,9420,9998,10557],0); -ELEMENTS[75488] = Fluid3D([10918,12034,11995,11314],0); -ELEMENTS[75489] = Fluid3D([10557,10786,9420,9998],0); -ELEMENTS[75490] = Fluid3D([11786,11314,10873,11969],0); -ELEMENTS[75491] = Fluid3D([11146,9998,10185,10786],0); -ELEMENTS[75492] = Fluid3D([9420,9806,10557,9622],0); -ELEMENTS[75493] = Fluid3D([12262,11786,10873,12034],0); -ELEMENTS[75494] = Fluid3D([12262,11786,12034,12248],0); -ELEMENTS[75495] = Fluid3D([10266,9622,9943,9386],0); -ELEMENTS[75496] = Fluid3D([9672,10571,10873,10557],0); -ELEMENTS[75497] = Fluid3D([12262,11314,12034,10873],0); -ELEMENTS[75498] = Fluid3D([11506,10786,11969,11537],0); -ELEMENTS[75499] = Fluid3D([9622,9943,9386,8897],0); -ELEMENTS[75500] = Fluid3D([10571,10873,10557,11969],0); -ELEMENTS[75501] = Fluid3D([11786,12034,12248,10873],0); -ELEMENTS[75502] = Fluid3D([12034,12262,12248,13407],0); -ELEMENTS[75503] = Fluid3D([10812,11080,10873,12248],0); -ELEMENTS[75504] = Fluid3D([12248,12034,11080,10873],0); -ELEMENTS[75505] = Fluid3D([9622,9672,10873,10557],0); -ELEMENTS[75506] = Fluid3D([4781,4442,5334,4754],0); -ELEMENTS[75507] = Fluid3D([5355,5040,4912,5474],0); -ELEMENTS[75508] = Fluid3D([3991,4077,4644,4102],0); -ELEMENTS[75509] = Fluid3D([3991,4077,4102,3595],0); -ELEMENTS[75510] = Fluid3D([2350,2468,2701,2743],0); -ELEMENTS[75511] = Fluid3D([17525,17191,17278,16795],0); -ELEMENTS[75512] = Fluid3D([6437,6342,5989,7016],0); -ELEMENTS[75513] = Fluid3D([13925,13807,14644,14175],0); -ELEMENTS[75514] = Fluid3D([14676,14271,14382,14984],0); -ELEMENTS[75515] = Fluid3D([14427,14840,14211,15190],0); -ELEMENTS[75516] = Fluid3D([4871,5027,5598,5084],0); -ELEMENTS[75517] = Fluid3D([9837,9392,9177,9723],0); -ELEMENTS[75518] = Fluid3D([11142,11156,10188,11662],0); -ELEMENTS[75519] = Fluid3D([12064,11608,10688,11199],0); -ELEMENTS[75520] = Fluid3D([11608,10688,11199,11186],0); -ELEMENTS[75521] = Fluid3D([2254,2058,2211,2342],0); -ELEMENTS[75522] = Fluid3D([7156,6370,6491,6937],0); -ELEMENTS[75523] = Fluid3D([18641,18668,18630,18647],0); -ELEMENTS[75524] = Fluid3D([17644,17687,18046,17822],0); -ELEMENTS[75525] = Fluid3D([13615,13275,14037,14522],0); -ELEMENTS[75526] = Fluid3D([11729,11921,11030,12190],0); -ELEMENTS[75527] = Fluid3D([14597,14348,14437,15360],0); -ELEMENTS[75528] = Fluid3D([15907,16063,15826,16443],0); -ELEMENTS[75529] = Fluid3D([11135,10142,10638,11164],0); -ELEMENTS[75530] = Fluid3D([16738,16718,16434,16781],0); -ELEMENTS[75531] = Fluid3D([11457,11027,10108,10622],0); -ELEMENTS[75532] = Fluid3D([11457,11027,10622,11541],0); -ELEMENTS[75533] = Fluid3D([5025,4685,4186,4377],0); -ELEMENTS[75534] = Fluid3D([14838,14346,13615,13962],0); -ELEMENTS[75535] = Fluid3D([12921,13586,14120,13827],0); -ELEMENTS[75536] = Fluid3D([5808,6131,6619,5830],0); -ELEMENTS[75537] = Fluid3D([3361,3120,2998,2756],0); -ELEMENTS[75538] = Fluid3D([1821,1941,1767,1910],0); -ELEMENTS[75539] = Fluid3D([8807,8756,9531,8759],0); -ELEMENTS[75540] = Fluid3D([14433,14602,13555,13609],0); -ELEMENTS[75541] = Fluid3D([15002,14486,15318,15645],0); -ELEMENTS[75542] = Fluid3D([16374,16829,16639,16784],0); -ELEMENTS[75543] = Fluid3D([7784,7354,7524,8471],0); -ELEMENTS[75544] = Fluid3D([8289,8747,9362,9801],0); -ELEMENTS[75545] = Fluid3D([12674,13219,13276,12658],0); -ELEMENTS[75546] = Fluid3D([9590,9710,8840,9377],0); -ELEMENTS[75547] = Fluid3D([11172,12048,11184,11884],0); -ELEMENTS[75548] = Fluid3D([14462,14465,15254,15537],0); -ELEMENTS[75549] = Fluid3D([16994,17290,17033,17480],0); -ELEMENTS[75550] = Fluid3D([16994,17290,17480,17639],0); -ELEMENTS[75551] = Fluid3D([12836,13445,12985,13410],0); -ELEMENTS[75552] = Fluid3D([4908,4442,4498,4871],0); -ELEMENTS[75553] = Fluid3D([4908,4442,4871,5334],0); -ELEMENTS[75554] = Fluid3D([10374,10922,10188,10225],0); -ELEMENTS[75555] = Fluid3D([18548,18624,18658,18618],0); -ELEMENTS[75556] = Fluid3D([18624,18658,18618,18630],0); -ELEMENTS[75557] = Fluid3D([10479,10118,9962,9143],0); -ELEMENTS[75558] = Fluid3D([6100,6744,6206,6138],0); -ELEMENTS[75559] = Fluid3D([9870,10319,10998,10475],0); -ELEMENTS[75560] = Fluid3D([11736,11685,11195,10354],0); -ELEMENTS[75561] = Fluid3D([10674,10678,10829,10316],0); -ELEMENTS[75562] = Fluid3D([15145,15579,15064,15653],0); -ELEMENTS[75563] = Fluid3D([15878,16013,15986,16704],0); -ELEMENTS[75564] = Fluid3D([2028,1917,2126,2193],0); -ELEMENTS[75565] = Fluid3D([2108,2232,1941,2220],0); -ELEMENTS[75566] = Fluid3D([15014,15567,14856,14500],0); -ELEMENTS[75567] = Fluid3D([14856,15014,14500,14086],0); -ELEMENTS[75568] = Fluid3D([16319,16461,16123,16968],0); -ELEMENTS[75569] = Fluid3D([4816,5038,4405,5014],0); -ELEMENTS[75570] = Fluid3D([4742,5105,5612,4765],0); -ELEMENTS[75571] = Fluid3D([16769,16910,16373,16164],0); -ELEMENTS[75572] = Fluid3D([4463,4129,4239,4668],0); -ELEMENTS[75573] = Fluid3D([11421,11444,12466,11310],0); -ELEMENTS[75574] = Fluid3D([11421,11444,11310,10469],0); -ELEMENTS[75575] = Fluid3D([8342,8756,8503,8635],0); -ELEMENTS[75576] = Fluid3D([12800,13283,12399,12610],0); -ELEMENTS[75577] = Fluid3D([12800,13283,12610,14116],0); -ELEMENTS[75578] = Fluid3D([17238,16777,17111,16963],0); -ELEMENTS[75579] = Fluid3D([6466,6720,6853,6109],0); -ELEMENTS[75580] = Fluid3D([14820,14518,15120,14368],0); -ELEMENTS[75581] = Fluid3D([6534,7213,6347,7333],0); -ELEMENTS[75582] = Fluid3D([8863,9573,8389,8808],0); -ELEMENTS[75583] = Fluid3D([4344,4220,3737,3950],0); -ELEMENTS[75584] = Fluid3D([1885,2021,1821,2079],0); -ELEMENTS[75585] = Fluid3D([1885,2021,2079,2043],0); -ELEMENTS[75586] = Fluid3D([1885,2021,2043,2106],0); -ELEMENTS[75587] = Fluid3D([16010,16262,15940,15297],0); -ELEMENTS[75588] = Fluid3D([5866,5252,6240,5791],0); -ELEMENTS[75589] = Fluid3D([11692,11411,11702,12619],0); -ELEMENTS[75590] = Fluid3D([8349,9056,8853,8675],0); -ELEMENTS[75591] = Fluid3D([8349,9056,8675,8453],0); -ELEMENTS[75592] = Fluid3D([8675,8349,8453,7519],0); -ELEMENTS[75593] = Fluid3D([8349,9056,8453,9237],0); -ELEMENTS[75594] = Fluid3D([15798,15725,16014,16376],0); -ELEMENTS[75595] = Fluid3D([10818,11240,11077,9919],0); -ELEMENTS[75596] = Fluid3D([6164,6873,6504,6396],0); -ELEMENTS[75597] = Fluid3D([4830,5347,5285,5355],0); -ELEMENTS[75598] = Fluid3D([9872,9703,9720,10795],0); -ELEMENTS[75599] = Fluid3D([14719,14405,14038,13520],0); -ELEMENTS[75600] = Fluid3D([7379,8312,7502,7742],0); -ELEMENTS[75601] = Fluid3D([2628,2847,2456,2812],0); -ELEMENTS[75602] = Fluid3D([7497,7016,6437,6714],0); -ELEMENTS[75603] = Fluid3D([6479,6988,7025,7661],0); -ELEMENTS[75604] = Fluid3D([14583,14751,15361,14941],0); -ELEMENTS[75605] = Fluid3D([14583,14751,14941,13809],0); -ELEMENTS[75606] = Fluid3D([18143,17841,18088,18097],0); -ELEMENTS[75607] = Fluid3D([4305,4897,4442,4754],0); -ELEMENTS[75608] = Fluid3D([18315,18289,18117,17932],0); -ELEMENTS[75609] = Fluid3D([1812,1933,2047,2018],0); -ELEMENTS[75610] = Fluid3D([12939,12622,13411,12910],0); -ELEMENTS[75611] = Fluid3D([11272,11483,12002,10946],0); -ELEMENTS[75612] = Fluid3D([12002,11272,10946,11033],0); -ELEMENTS[75613] = Fluid3D([18150,17853,18066,17834],0); -ELEMENTS[75614] = Fluid3D([3122,3313,3215,2927],0); -ELEMENTS[75615] = Fluid3D([3215,3122,2927,2705],0); -ELEMENTS[75616] = Fluid3D([13886,14257,13547,13985],0); -ELEMENTS[75617] = Fluid3D([9331,9382,9687,10475],0); -ELEMENTS[75618] = Fluid3D([14253,14772,13954,13881],0); -ELEMENTS[75619] = Fluid3D([3600,3839,3419,3261],0); -ELEMENTS[75620] = Fluid3D([8566,9464,8552,9781],0); -ELEMENTS[75621] = Fluid3D([3905,4319,3680,4237],0); -ELEMENTS[75622] = Fluid3D([14064,13429,14532,13711],0); -ELEMENTS[75623] = Fluid3D([13992,14598,13428,13571],0); -ELEMENTS[75624] = Fluid3D([13428,13992,13571,13307],0); -ELEMENTS[75625] = Fluid3D([6007,5989,6342,7016],0); -ELEMENTS[75626] = Fluid3D([9645,10626,9161,9692],0); -ELEMENTS[75627] = Fluid3D([2717,2813,2415,2605],0); -ELEMENTS[75628] = Fluid3D([7754,8373,7918,7446],0); -ELEMENTS[75629] = Fluid3D([7754,8373,7446,8294],0); -ELEMENTS[75630] = Fluid3D([12900,13613,12646,13097],0); -ELEMENTS[75631] = Fluid3D([12900,13613,13097,12921],0); -ELEMENTS[75632] = Fluid3D([10709,11254,11206,10238],0); -ELEMENTS[75633] = Fluid3D([14893,14308,14608,14300],0); -ELEMENTS[75634] = Fluid3D([11452,10781,10051,10678],0); -ELEMENTS[75635] = Fluid3D([2871,2878,2692,3164],0); -ELEMENTS[75636] = Fluid3D([6879,6788,7392,6476],0); -ELEMENTS[75637] = Fluid3D([8203,8335,9173,8921],0); -ELEMENTS[75638] = Fluid3D([8979,9604,9950,10364],0); -ELEMENTS[75639] = Fluid3D([16878,16555,16152,16160],0); -ELEMENTS[75640] = Fluid3D([10308,10838,11358,11845],0); -ELEMENTS[75641] = Fluid3D([10195,9890,10013,9050],0); -ELEMENTS[75642] = Fluid3D([3180,3147,2940,2721],0); -ELEMENTS[75643] = Fluid3D([3386,3426,3682,3286],0); -ELEMENTS[75644] = Fluid3D([3248,3202,3182,3797],0); -ELEMENTS[75645] = Fluid3D([11842,11939,10988,11495],0); -ELEMENTS[75646] = Fluid3D([17424,17462,17270,17008],0); -ELEMENTS[75647] = Fluid3D([13218,13923,14284,13334],0); -ELEMENTS[75648] = Fluid3D([6885,6776,7775,7090],0); -ELEMENTS[75649] = Fluid3D([5566,6520,6185,5824],0); -ELEMENTS[75650] = Fluid3D([13366,12484,13103,13612],0); -ELEMENTS[75651] = Fluid3D([1938,1932,1840,1722],0); -ELEMENTS[75652] = Fluid3D([17461,17442,17735,17519],0); -ELEMENTS[75653] = Fluid3D([9052,9485,8157,8749],0); -ELEMENTS[75654] = Fluid3D([12318,11827,11961,11665],0); -ELEMENTS[75655] = Fluid3D([11827,11961,11665,10943],0); -ELEMENTS[75656] = Fluid3D([18168,17887,18070,17813],0); -ELEMENTS[75657] = Fluid3D([18168,17887,17813,18063],0); -ELEMENTS[75658] = Fluid3D([1621,1553,1625,1641],0); -ELEMENTS[75659] = Fluid3D([7191,7140,6441,7269],0); -ELEMENTS[75660] = Fluid3D([6441,7191,7269,6574],0); -ELEMENTS[75661] = Fluid3D([10115,10982,10772,9676],0); -ELEMENTS[75662] = Fluid3D([9935,9274,9584,10372],0); -ELEMENTS[75663] = Fluid3D([11168,10978,9923,10258],0); -ELEMENTS[75664] = Fluid3D([6671,6753,6136,5707],0); -ELEMENTS[75665] = Fluid3D([12933,11782,12910,11551],0); -ELEMENTS[75666] = Fluid3D([15530,16100,15616,15341],0); -ELEMENTS[75667] = Fluid3D([14670,13971,14322,15055],0); -ELEMENTS[75668] = Fluid3D([2725,2718,3077,2772],0); -ELEMENTS[75669] = Fluid3D([14181,13611,13596,13175],0); -ELEMENTS[75670] = Fluid3D([5977,6591,6255,7146],0); -ELEMENTS[75671] = Fluid3D([18086,18063,18004,17720],0); -ELEMENTS[75672] = Fluid3D([3548,3861,3250,3623],0); -ELEMENTS[75673] = Fluid3D([17393,17495,17378,16976],0); -ELEMENTS[75674] = Fluid3D([11184,10994,11172,11884],0); -ELEMENTS[75675] = Fluid3D([8073,8165,7461,8621],0); -ELEMENTS[75676] = Fluid3D([10626,10127,9161,10188],0); -ELEMENTS[75677] = Fluid3D([4683,4129,4811,4463],0); -ELEMENTS[75678] = Fluid3D([18106,18291,17919,18134],0); -ELEMENTS[75679] = Fluid3D([13814,13282,13731,14350],0); -ELEMENTS[75680] = Fluid3D([7848,8462,8671,8791],0); -ELEMENTS[75681] = Fluid3D([3826,3885,3982,3560],0); -ELEMENTS[75682] = Fluid3D([6038,5522,5959,5948],0); -ELEMENTS[75683] = Fluid3D([10218,9471,9045,9903],0); -ELEMENTS[75684] = Fluid3D([16441,15971,16379,16706],0); -ELEMENTS[75685] = Fluid3D([3061,2847,2628,2812],0); -ELEMENTS[75686] = Fluid3D([12885,12598,11719,12107],0); -ELEMENTS[75687] = Fluid3D([1989,2262,2075,2250],0); -ELEMENTS[75688] = Fluid3D([1976,1964,1849,2109],0); -ELEMENTS[75689] = Fluid3D([14502,14968,15153,15169],0); -ELEMENTS[75690] = Fluid3D([10188,11156,10225,10922],0); -ELEMENTS[75691] = Fluid3D([17241,17216,16757,16954],0); -ELEMENTS[75692] = Fluid3D([2144,1978,2106,2211],0); -ELEMENTS[75693] = Fluid3D([14659,15242,15288,15176],0); -ELEMENTS[75694] = Fluid3D([3829,3982,3590,4039],0); -ELEMENTS[75695] = Fluid3D([16057,15434,15629,15957],0); -ELEMENTS[75696] = Fluid3D([2493,2718,2497,2400],0); -ELEMENTS[75697] = Fluid3D([5589,5726,5108,5002],0); -ELEMENTS[75698] = Fluid3D([11675,11746,11161,12044],0); -ELEMENTS[75699] = Fluid3D([15096,15325,15619,15844],0); -ELEMENTS[75700] = Fluid3D([4156,3773,3837,4294],0); -ELEMENTS[75701] = Fluid3D([14125,14350,13990,13282],0); -ELEMENTS[75702] = Fluid3D([15282,14864,15656,15463],0); -ELEMENTS[75703] = Fluid3D([9554,9720,9703,10795],0); -ELEMENTS[75704] = Fluid3D([16796,16902,16350,16876],0); -ELEMENTS[75705] = Fluid3D([16350,16796,16876,16882],0); -ELEMENTS[75706] = Fluid3D([12891,12227,11823,12538],0); -ELEMENTS[75707] = Fluid3D([12159,11979,11379,12128],0); -ELEMENTS[75708] = Fluid3D([12887,11981,12896,12901],0); -ELEMENTS[75709] = Fluid3D([16300,16010,15940,15297],0); -ELEMENTS[75710] = Fluid3D([16201,16858,16501,15927],0); -ELEMENTS[75711] = Fluid3D([8282,7717,7489,7458],0); -ELEMENTS[75712] = Fluid3D([8846,8784,7791,9152],0); -ELEMENTS[75713] = Fluid3D([3535,3914,3696,3316],0); -ELEMENTS[75714] = Fluid3D([9720,10661,10822,10795],0); -ELEMENTS[75715] = Fluid3D([15419,14661,15073,14793],0); -ELEMENTS[75716] = Fluid3D([15757,15263,15565,15033],0); -ELEMENTS[75717] = Fluid3D([6827,6671,6136,5707],0); -ELEMENTS[75718] = Fluid3D([14360,15006,14637,14856],0); -ELEMENTS[75719] = Fluid3D([4442,4394,4498,4015],0); -ELEMENTS[75720] = Fluid3D([14704,14625,15399,15385],0); -ELEMENTS[75721] = Fluid3D([3060,3418,3506,3138],0); -ELEMENTS[75722] = Fluid3D([4325,3881,3980,3714],0); -ELEMENTS[75723] = Fluid3D([3326,3491,2974,2931],0); -ELEMENTS[75724] = Fluid3D([15579,16108,15841,16363],0); -ELEMENTS[75725] = Fluid3D([15915,16550,16133,16277],0); -ELEMENTS[75726] = Fluid3D([10006,10439,11152,10925],0); -ELEMENTS[75727] = Fluid3D([13429,14175,14532,13807],0); -ELEMENTS[75728] = Fluid3D([18270,18092,18037,18079],0); -ELEMENTS[75729] = Fluid3D([18037,18270,18079,18325],0); -ELEMENTS[75730] = Fluid3D([4699,4579,4307,3983],0); -ELEMENTS[75731] = Fluid3D([14772,14729,14980,14614],0); -ELEMENTS[75732] = Fluid3D([14772,14729,14614,14123],0); -ELEMENTS[75733] = Fluid3D([5996,6368,5615,6251],0); -ELEMENTS[75734] = Fluid3D([8886,9683,8576,9404],0); -ELEMENTS[75735] = Fluid3D([6248,5779,5486,5352],0); -ELEMENTS[75736] = Fluid3D([18151,18084,18272,18193],0); -ELEMENTS[75737] = Fluid3D([15222,15470,15728,14881],0); -ELEMENTS[75738] = Fluid3D([6780,7537,7330,6680],0); -ELEMENTS[75739] = Fluid3D([14630,15188,14482,15147],0); -ELEMENTS[75740] = Fluid3D([13765,12984,13092,12212],0); -ELEMENTS[75741] = Fluid3D([17538,17457,17172,17698],0); -ELEMENTS[75742] = Fluid3D([16312,16068,16588,16874],0); -ELEMENTS[75743] = Fluid3D([16461,16837,16528,16968],0); -ELEMENTS[75744] = Fluid3D([10512,10585,9727,9284],0); -ELEMENTS[75745] = Fluid3D([18024,18098,18130,17904],0); -ELEMENTS[75746] = Fluid3D([18130,18024,17904,17671],0); -ELEMENTS[75747] = Fluid3D([15716,15295,15883,16269],0); -ELEMENTS[75748] = Fluid3D([12362,11470,12138,12281],0); -ELEMENTS[75749] = Fluid3D([2232,2027,2130,2403],0); -ELEMENTS[75750] = Fluid3D([7583,8079,7886,6993],0); -ELEMENTS[75751] = Fluid3D([16470,16784,17112,16962],0); -ELEMENTS[75752] = Fluid3D([5118,5018,5805,5476],0); -ELEMENTS[75753] = Fluid3D([2437,2468,2132,2350],0); -ELEMENTS[75754] = Fluid3D([2437,2468,2350,2578],0); -ELEMENTS[75755] = Fluid3D([9836,10408,9299,9724],0); -ELEMENTS[75756] = Fluid3D([10191,9119,9463,8884],0); -ELEMENTS[75757] = Fluid3D([7333,7285,7475,6442],0); -ELEMENTS[75758] = Fluid3D([2744,2741,3060,2778],0); -ELEMENTS[75759] = Fluid3D([3060,2744,2778,3206],0); -ELEMENTS[75760] = Fluid3D([2778,3060,3206,2928],0); -ELEMENTS[75761] = Fluid3D([2778,3060,2928,3138],0); -ELEMENTS[75762] = Fluid3D([8531,9487,9029,8540],0); -ELEMENTS[75763] = Fluid3D([17824,17622,17469,17602],0); -ELEMENTS[75764] = Fluid3D([15214,14968,15494,15762],0); -ELEMENTS[75765] = Fluid3D([16201,16060,15716,15927],0); -ELEMENTS[75766] = Fluid3D([14246,13631,14257,13390],0); -ELEMENTS[75767] = Fluid3D([13882,14374,14958,14795],0); -ELEMENTS[75768] = Fluid3D([3814,3839,3746,4389],0); -ELEMENTS[75769] = Fluid3D([10520,11339,11707,11534],0); -ELEMENTS[75770] = Fluid3D([3817,3426,3229,3471],0); -ELEMENTS[75771] = Fluid3D([16415,16341,16362,15801],0); -ELEMENTS[75772] = Fluid3D([11098,10454,10386,11460],0); -ELEMENTS[75773] = Fluid3D([17727,17313,17769,17293],0); -ELEMENTS[75774] = Fluid3D([4778,4724,5195,4425],0); -ELEMENTS[75775] = Fluid3D([7367,7267,8374,8201],0); -ELEMENTS[75776] = Fluid3D([16546,16147,16822,16368],0); -ELEMENTS[75777] = Fluid3D([9140,9506,10494,9377],0); -ELEMENTS[75778] = Fluid3D([16691,17061,17085,16873],0); -ELEMENTS[75779] = Fluid3D([5916,5429,5032,5191],0); -ELEMENTS[75780] = Fluid3D([17220,16972,16551,16729],0); -ELEMENTS[75781] = Fluid3D([6521,6926,6028,6979],0); -ELEMENTS[75782] = Fluid3D([6926,6028,6979,6178],0); -ELEMENTS[75783] = Fluid3D([18409,18373,18355,18158],0); -ELEMENTS[75784] = Fluid3D([15378,15436,14891,14495],0); -ELEMENTS[75785] = Fluid3D([14452,14802,14142,13667],0); -ELEMENTS[75786] = Fluid3D([6383,6996,6135,6244],0); -ELEMENTS[75787] = Fluid3D([13280,12969,13023,14073],0); -ELEMENTS[75788] = Fluid3D([15489,15556,15347,14696],0); -ELEMENTS[75789] = Fluid3D([16897,16379,17105,16806],0); -ELEMENTS[75790] = Fluid3D([7475,7501,8296,7213],0); -ELEMENTS[75791] = Fluid3D([18423,18477,18228,18202],0); -ELEMENTS[75792] = Fluid3D([13571,12610,13307,14116],0); -ELEMENTS[75793] = Fluid3D([18402,18272,18193,18151],0); -ELEMENTS[75794] = Fluid3D([5092,5644,5314,5361],0); -ELEMENTS[75795] = Fluid3D([6256,5983,6059,5428],0); -ELEMENTS[75796] = Fluid3D([6141,6431,5767,6102],0); -ELEMENTS[75797] = Fluid3D([16857,17123,17296,17322],0); -ELEMENTS[75798] = Fluid3D([7776,6936,7970,8055],0); -ELEMENTS[75799] = Fluid3D([8808,7871,8389,8863],0); -ELEMENTS[75800] = Fluid3D([14650,15356,14932,14780],0); -ELEMENTS[75801] = Fluid3D([14650,15356,14780,14929],0); -ELEMENTS[75802] = Fluid3D([3693,3830,3725,3314],0); -ELEMENTS[75803] = Fluid3D([18403,18273,18095,18188],0); -ELEMENTS[75804] = Fluid3D([10893,10796,10199,11196],0); -ELEMENTS[75805] = Fluid3D([17086,16784,17112,17276],0); -ELEMENTS[75806] = Fluid3D([14120,14444,13827,13586],0); -ELEMENTS[75807] = Fluid3D([14120,14444,13586,13490],0); -ELEMENTS[75808] = Fluid3D([14374,13882,13606,14833],0); -ELEMENTS[75809] = Fluid3D([12831,13525,12884,12549],0); -ELEMENTS[75810] = Fluid3D([9850,9151,9467,8427],0); -ELEMENTS[75811] = Fluid3D([2957,3024,2777,3018],0); -ELEMENTS[75812] = Fluid3D([3544,3918,3917,4287],0); -ELEMENTS[75813] = Fluid3D([17872,18147,17699,17935],0); -ELEMENTS[75814] = Fluid3D([14271,13807,13297,14382],0); -ELEMENTS[75815] = Fluid3D([17176,17214,17325,16882],0); -ELEMENTS[75816] = Fluid3D([14370,14331,15142,14732],0); -ELEMENTS[75817] = Fluid3D([6688,6391,6245,6102],0); -ELEMENTS[75818] = Fluid3D([6688,6391,6102,6581],0); -ELEMENTS[75819] = Fluid3D([4531,5094,4775,4883],0); -ELEMENTS[75820] = Fluid3D([16374,16593,16158,16676],0); -ELEMENTS[75821] = Fluid3D([13916,14028,14459,13952],0); -ELEMENTS[75822] = Fluid3D([16371,16016,16667,15697],0); -ELEMENTS[75823] = Fluid3D([13202,13601,12561,12416],0); -ELEMENTS[75824] = Fluid3D([5648,5687,6112,6657],0); -ELEMENTS[75825] = Fluid3D([4543,4206,4143,3982],0); -ELEMENTS[75826] = Fluid3D([12125,11346,12160,12191],0); -ELEMENTS[75827] = Fluid3D([10441,10021,10688,11237],0); -ELEMENTS[75828] = Fluid3D([6879,7712,7629,7040],0); -ELEMENTS[75829] = Fluid3D([7712,7629,7040,7431],0); -ELEMENTS[75830] = Fluid3D([14493,15539,15160,14796],0); -ELEMENTS[75831] = Fluid3D([7616,7314,8125,7167],0); -ELEMENTS[75832] = Fluid3D([9963,9860,9591,10679],0); -ELEMENTS[75833] = Fluid3D([5852,6316,5601,5908],0); -ELEMENTS[75834] = Fluid3D([11198,11495,12138,12281],0); -ELEMENTS[75835] = Fluid3D([4414,4182,4035,4204],0); -ELEMENTS[75836] = Fluid3D([17407,16979,17226,17312],0); -ELEMENTS[75837] = Fluid3D([16929,16456,16669,17099],0); -ELEMENTS[75838] = Fluid3D([11520,10157,10293,11171],0); -ELEMENTS[75839] = Fluid3D([9311,8322,8497,8402],0); -ELEMENTS[75840] = Fluid3D([9223,8708,8056,8807],0); -ELEMENTS[75841] = Fluid3D([12794,12739,13336,13807],0); -ELEMENTS[75842] = Fluid3D([12794,12739,13807,13321],0); -ELEMENTS[75843] = Fluid3D([7133,7171,7608,6860],0); -ELEMENTS[75844] = Fluid3D([9472,9940,10893,10094],0); -ELEMENTS[75845] = Fluid3D([6808,6078,6102,5882],0); -ELEMENTS[75846] = Fluid3D([11922,12237,12683,11861],0); -ELEMENTS[75847] = Fluid3D([3291,3506,3138,3060],0); -ELEMENTS[75848] = Fluid3D([15191,14929,15583,15820],0); -ELEMENTS[75849] = Fluid3D([4442,4394,4015,3780],0); -ELEMENTS[75850] = Fluid3D([8302,7581,8771,8524],0); -ELEMENTS[75851] = Fluid3D([11646,11914,12947,12691],0); -ELEMENTS[75852] = Fluid3D([11646,11914,12691,12512],0); -ELEMENTS[75853] = Fluid3D([7698,8417,7777,7866],0); -ELEMENTS[75854] = Fluid3D([8417,7777,7866,8751],0); -ELEMENTS[75855] = Fluid3D([13888,14354,13315,13784],0); -ELEMENTS[75856] = Fluid3D([8335,8203,8145,8921],0); -ELEMENTS[75857] = Fluid3D([7543,8209,7621,7403],0); -ELEMENTS[75858] = Fluid3D([5643,4979,4896,5384],0); -ELEMENTS[75859] = Fluid3D([11807,10670,11972,10760],0); -ELEMENTS[75860] = Fluid3D([16502,16694,16754,16265],0); -ELEMENTS[75861] = Fluid3D([17430,17140,17452,17138],0); -ELEMENTS[75862] = Fluid3D([10876,9902,10666,10606],0); -ELEMENTS[75863] = Fluid3D([4521,4494,3805,3890],0); -ELEMENTS[75864] = Fluid3D([15006,14637,14856,15515],0); -ELEMENTS[75865] = Fluid3D([9150,9566,9940,10351],0); -ELEMENTS[75866] = Fluid3D([15701,16025,16544,16131],0); -ELEMENTS[75867] = Fluid3D([15304,15095,15449,14711],0); -ELEMENTS[75868] = Fluid3D([17424,17270,16968,17008],0); -ELEMENTS[75869] = Fluid3D([4527,4226,4086,3934],0); -ELEMENTS[75870] = Fluid3D([3299,3534,3659,3966],0); -ELEMENTS[75871] = Fluid3D([12301,13083,12922,12737],0); -ELEMENTS[75872] = Fluid3D([6198,5679,5627,5442],0); -ELEMENTS[75873] = Fluid3D([7753,6987,7258,8042],0); -ELEMENTS[75874] = Fluid3D([16200,16378,16341,16525],0); -ELEMENTS[75875] = Fluid3D([16107,16506,16522,15925],0); -ELEMENTS[75876] = Fluid3D([18436,18547,18474,18577],0); -ELEMENTS[75877] = Fluid3D([5932,5454,5562,6376],0); -ELEMENTS[75878] = Fluid3D([18270,18223,18379,18325],0); -ELEMENTS[75879] = Fluid3D([12316,13114,12347,11811],0); -ELEMENTS[75880] = Fluid3D([11692,11791,12382,12987],0); -ELEMENTS[75881] = Fluid3D([3273,3260,2935,2956],0); -ELEMENTS[75882] = Fluid3D([7148,7586,6918,7147],0); -ELEMENTS[75883] = Fluid3D([17061,17269,17085,17364],0); -ELEMENTS[75884] = Fluid3D([17085,17061,17364,16873],0); -ELEMENTS[75885] = Fluid3D([8921,9728,9521,9173],0); -ELEMENTS[75886] = Fluid3D([5764,5992,6879,6556],0); -ELEMENTS[75887] = Fluid3D([3253,3578,3458,2955],0); -ELEMENTS[75888] = Fluid3D([11632,11675,12684,11995],0); -ELEMENTS[75889] = Fluid3D([16221,16547,16985,16674],0); -ELEMENTS[75890] = Fluid3D([15705,15719,15390,14859],0); -ELEMENTS[75891] = Fluid3D([18192,18223,18441,18332],0); -ELEMENTS[75892] = Fluid3D([15894,15525,16291,15316],0); -ELEMENTS[75893] = Fluid3D([10874,11601,11424,12253],0); -ELEMENTS[75894] = Fluid3D([14253,13954,13319,13881],0); -ELEMENTS[75895] = Fluid3D([8283,9120,8132,7908],0); -ELEMENTS[75896] = Fluid3D([8283,9120,7908,8475],0); -ELEMENTS[75897] = Fluid3D([8121,8925,8375,8345],0); -ELEMENTS[75898] = Fluid3D([18138,18202,18424,18286],0); -ELEMENTS[75899] = Fluid3D([7910,7916,6934,7595],0); -ELEMENTS[75900] = Fluid3D([16680,16954,17241,16757],0); -ELEMENTS[75901] = Fluid3D([16084,16193,16686,16259],0); -ELEMENTS[75902] = Fluid3D([16686,16084,16259,16448],0); -ELEMENTS[75903] = Fluid3D([9213,9556,10263,10007],0); -ELEMENTS[75904] = Fluid3D([14447,15076,14257,15193],0); -ELEMENTS[75905] = Fluid3D([5967,6602,6315,5671],0); -ELEMENTS[75906] = Fluid3D([5851,5396,5682,5002],0); -ELEMENTS[75907] = Fluid3D([11981,12887,11671,11797],0); -ELEMENTS[75908] = Fluid3D([11128,11043,12336,11814],0); -ELEMENTS[75909] = Fluid3D([7431,8132,7712,7629],0); -ELEMENTS[75910] = Fluid3D([16732,16294,16858,16966],0); -ELEMENTS[75911] = Fluid3D([17822,17928,18046,17644],0); -ELEMENTS[75912] = Fluid3D([16765,17092,16821,16912],0); -ELEMENTS[75913] = Fluid3D([11063,10453,9724,9612],0); -ELEMENTS[75914] = Fluid3D([13471,13440,13768,14348],0); -ELEMENTS[75915] = Fluid3D([13440,13768,14348,14437],0); -ELEMENTS[75916] = Fluid3D([15592,15958,16133,15915],0); -ELEMENTS[75917] = Fluid3D([8815,8066,9179,8226],0); -ELEMENTS[75918] = Fluid3D([7458,7960,8282,7717],0); -ELEMENTS[75919] = Fluid3D([12368,11898,11418,10700],0); -ELEMENTS[75920] = Fluid3D([7319,6718,6341,6526],0); -ELEMENTS[75921] = Fluid3D([13790,13933,13217,12657],0); -ELEMENTS[75922] = Fluid3D([7355,7526,6709,7690],0); -ELEMENTS[75923] = Fluid3D([8209,7740,8877,9108],0); -ELEMENTS[75924] = Fluid3D([7213,7333,7475,6442],0); -ELEMENTS[75925] = Fluid3D([13215,12507,12088,12884],0); -ELEMENTS[75926] = Fluid3D([17326,17424,16968,17243],0); -ELEMENTS[75927] = Fluid3D([2483,2298,2198,2163],0); -ELEMENTS[75928] = Fluid3D([10640,10743,10012,10956],0); -ELEMENTS[75929] = Fluid3D([15964,15904,15762,16558],0); -ELEMENTS[75930] = Fluid3D([3726,4225,3838,3938],0); -ELEMENTS[75931] = Fluid3D([6602,5967,5845,5671],0); -ELEMENTS[75932] = Fluid3D([17574,17140,17452,17536],0); -ELEMENTS[75933] = Fluid3D([14572,15007,15360,14437],0); -ELEMENTS[75934] = Fluid3D([17124,16910,16464,17106],0); -ELEMENTS[75935] = Fluid3D([4589,4059,4419,4036],0); -ELEMENTS[75936] = Fluid3D([14329,14587,15280,15469],0); -ELEMENTS[75937] = Fluid3D([9829,9188,9080,8484],0); -ELEMENTS[75938] = Fluid3D([14814,15111,14252,15337],0); -ELEMENTS[75939] = Fluid3D([12379,11454,11439,12405],0); -ELEMENTS[75940] = Fluid3D([12547,12973,12191,13400],0); -ELEMENTS[75941] = Fluid3D([8644,9176,9160,8243],0); -ELEMENTS[75942] = Fluid3D([11552,11046,10773,10406],0); -ELEMENTS[75943] = Fluid3D([17224,17401,17045,16805],0); -ELEMENTS[75944] = Fluid3D([3289,3340,3813,3692],0); -ELEMENTS[75945] = Fluid3D([13973,13470,14429,14792],0); -ELEMENTS[75946] = Fluid3D([6909,6429,6260,7072],0); -ELEMENTS[75947] = Fluid3D([18410,18527,18375,18314],0); -ELEMENTS[75948] = Fluid3D([10943,10642,11827,11961],0); -ELEMENTS[75949] = Fluid3D([17467,17224,17087,16848],0); -ELEMENTS[75950] = Fluid3D([2892,2687,3129,3150],0); -ELEMENTS[75951] = Fluid3D([12872,13329,13834,12946],0); -ELEMENTS[75952] = Fluid3D([7937,7284,7634,8323],0); -ELEMENTS[75953] = Fluid3D([7284,7634,8323,7818],0); -ELEMENTS[75954] = Fluid3D([13726,14236,13292,14307],0); -ELEMENTS[75955] = Fluid3D([14233,14350,15060,15257],0); -ELEMENTS[75956] = Fluid3D([15290,15025,15940,15297],0); -ELEMENTS[75957] = Fluid3D([10451,10582,10628,12252],0); -ELEMENTS[75958] = Fluid3D([14991,15309,14767,15618],0); -ELEMENTS[75959] = Fluid3D([15309,14767,15618,15270],0); -ELEMENTS[75960] = Fluid3D([14767,15618,15270,14662],0); -ELEMENTS[75961] = Fluid3D([17889,18015,17856,18158],0); -ELEMENTS[75962] = Fluid3D([17889,18015,18158,18266],0); -ELEMENTS[75963] = Fluid3D([18147,17954,17699,17935],0); -ELEMENTS[75964] = Fluid3D([14321,13637,13783,14379],0); -ELEMENTS[75965] = Fluid3D([13999,14275,14596,13693],0); -ELEMENTS[75966] = Fluid3D([15061,15380,14594,14379],0); -ELEMENTS[75967] = Fluid3D([10325,9708,9259,9132],0); -ELEMENTS[75968] = Fluid3D([13501,13316,14438,14464],0); -ELEMENTS[75969] = Fluid3D([11023,11905,11417,10888],0); -ELEMENTS[75970] = Fluid3D([9888,9097,9702,10346],0); -ELEMENTS[75971] = Fluid3D([12665,12231,12203,11391],0); -ELEMENTS[75972] = Fluid3D([16275,15673,15655,16454],0); -ELEMENTS[75973] = Fluid3D([4330,4747,4913,4609],0); -ELEMENTS[75974] = Fluid3D([16738,16440,16953,17190],0); -ELEMENTS[75975] = Fluid3D([17874,17889,17972,18266],0); -ELEMENTS[75976] = Fluid3D([11652,11397,11433,12531],0); -ELEMENTS[75977] = Fluid3D([14691,15193,15502,15386],0); -ELEMENTS[75978] = Fluid3D([14126,13390,13295,14023],0); -ELEMENTS[75979] = Fluid3D([11730,11728,12237,12979],0); -ELEMENTS[75980] = Fluid3D([6872,7428,7561,7361],0); -ELEMENTS[75981] = Fluid3D([2368,2320,2568,2425],0); -ELEMENTS[75982] = Fluid3D([17739,17605,17758,17807],0); -ELEMENTS[75983] = Fluid3D([6650,5975,6369,5891],0); -ELEMENTS[75984] = Fluid3D([7191,7140,7269,7825],0); -ELEMENTS[75985] = Fluid3D([7269,7191,7825,8293],0); -ELEMENTS[75986] = Fluid3D([15957,16303,15629,16057],0); -ELEMENTS[75987] = Fluid3D([4979,4896,5384,4935],0); -ELEMENTS[75988] = Fluid3D([5727,5335,6134,5957],0); -ELEMENTS[75989] = Fluid3D([1976,1849,1966,2109],0); -ELEMENTS[75990] = Fluid3D([9265,8830,9905,9753],0); -ELEMENTS[75991] = Fluid3D([12925,11935,13087,12924],0); -ELEMENTS[75992] = Fluid3D([7344,7446,7236,8294],0); -ELEMENTS[75993] = Fluid3D([5681,6238,6062,5784],0); -ELEMENTS[75994] = Fluid3D([3608,3837,3852,3773],0); -ELEMENTS[75995] = Fluid3D([5124,4880,4536,5251],0); -ELEMENTS[75996] = Fluid3D([5124,4880,5251,5822],0); -ELEMENTS[75997] = Fluid3D([12120,12602,12094,11294],0); -ELEMENTS[75998] = Fluid3D([17466,17690,17178,17176],0); -ELEMENTS[75999] = Fluid3D([4683,4129,4463,4668],0); -ELEMENTS[76000] = Fluid3D([15517,15815,15205,16007],0); -ELEMENTS[76001] = Fluid3D([9932,10008,11001,10821],0); -ELEMENTS[76002] = Fluid3D([15918,15380,15061,15175],0); -ELEMENTS[76003] = Fluid3D([15380,15061,15175,14379],0); -ELEMENTS[76004] = Fluid3D([10240,9957,9785,9973],0); -ELEMENTS[76005] = Fluid3D([17087,17467,16848,17350],0); -ELEMENTS[76006] = Fluid3D([15048,14208,15051,14414],0); -ELEMENTS[76007] = Fluid3D([5093,4672,4516,5168],0); -ELEMENTS[76008] = Fluid3D([4274,4022,4222,4912],0); -ELEMENTS[76009] = Fluid3D([10504,9660,10538,10376],0); -ELEMENTS[76010] = Fluid3D([12191,12495,13400,12973],0); -ELEMENTS[76011] = Fluid3D([9857,9417,8721,8441],0); -ELEMENTS[76012] = Fluid3D([3084,3376,3550,3530],0); -ELEMENTS[76013] = Fluid3D([12976,12655,13746,12688],0); -ELEMENTS[76014] = Fluid3D([10854,10970,10420,11526],0); -ELEMENTS[76015] = Fluid3D([6446,6458,5855,6660],0); -ELEMENTS[76016] = Fluid3D([9119,9839,9113,8884],0); -ELEMENTS[76017] = Fluid3D([9113,9119,8884,8344],0); -ELEMENTS[76018] = Fluid3D([6961,6777,7561,6304],0); -ELEMENTS[76019] = Fluid3D([4973,5149,4796,4284],0); -ELEMENTS[76020] = Fluid3D([2254,2391,2507,2518],0); -ELEMENTS[76021] = Fluid3D([2507,2254,2518,2211],0); -ELEMENTS[76022] = Fluid3D([14197,13977,13602,12851],0); -ELEMENTS[76023] = Fluid3D([11977,11602,12319,12857],0); -ELEMENTS[76024] = Fluid3D([11914,12593,12947,12856],0); -ELEMENTS[76025] = Fluid3D([11914,12593,12856,12059],0); -ELEMENTS[76026] = Fluid3D([8439,7662,7778,7454],0); -ELEMENTS[76027] = Fluid3D([8220,8640,8163,7777],0); -ELEMENTS[76028] = Fluid3D([17905,17951,18217,18123],0); -ELEMENTS[76029] = Fluid3D([4253,3970,3630,4054],0); -ELEMENTS[76030] = Fluid3D([2179,2170,1933,2047],0); -ELEMENTS[76031] = Fluid3D([4778,4587,4425,5195],0); -ELEMENTS[76032] = Fluid3D([11401,12308,11692,12845],0); -ELEMENTS[76033] = Fluid3D([4462,4507,3912,3946],0); -ELEMENTS[76034] = Fluid3D([4991,4507,4263,4751],0); -ELEMENTS[76035] = Fluid3D([5784,5355,5347,6062],0); -ELEMENTS[76036] = Fluid3D([15322,15937,16048,15875],0); -ELEMENTS[76037] = Fluid3D([15322,15937,15875,15860],0); -ELEMENTS[76038] = Fluid3D([9919,9697,9818,8743],0); -ELEMENTS[76039] = Fluid3D([18078,17755,17821,17889],0); -ELEMENTS[76040] = Fluid3D([11579,11455,12574,12151],0); -ELEMENTS[76041] = Fluid3D([12574,11579,12151,11731],0); -ELEMENTS[76042] = Fluid3D([18032,17647,17921,17846],0); -ELEMENTS[76043] = Fluid3D([5881,5153,5841,5043],0); -ELEMENTS[76044] = Fluid3D([12193,13028,12590,11634],0); -ELEMENTS[76045] = Fluid3D([16836,16567,16423,16082],0); -ELEMENTS[76046] = Fluid3D([7364,7278,7082,8302],0); -ELEMENTS[76047] = Fluid3D([7364,7278,8302,8415],0); -ELEMENTS[76048] = Fluid3D([16798,17040,16693,17145],0); -ELEMENTS[76049] = Fluid3D([7401,7034,6821,6126],0); -ELEMENTS[76050] = Fluid3D([7401,7034,6126,6320],0); -ELEMENTS[76051] = Fluid3D([5783,5477,5601,6014],0); -ELEMENTS[76052] = Fluid3D([3911,4126,3550,3752],0); -ELEMENTS[76053] = Fluid3D([12120,11976,11294,11087],0); -ELEMENTS[76054] = Fluid3D([6874,6789,6137,6224],0); -ELEMENTS[76055] = Fluid3D([12503,13084,12082,12894],0); -ELEMENTS[76056] = Fluid3D([12503,13084,12894,14096],0); -ELEMENTS[76057] = Fluid3D([12082,12503,12894,11726],0); -ELEMENTS[76058] = Fluid3D([7395,7126,7299,6396],0); -ELEMENTS[76059] = Fluid3D([2844,2914,3053,2542],0); -ELEMENTS[76060] = Fluid3D([6034,5409,5449,5612],0); -ELEMENTS[76061] = Fluid3D([16546,16822,16570,16368],0); -ELEMENTS[76062] = Fluid3D([8875,9619,10414,9824],0); -ELEMENTS[76063] = Fluid3D([10319,9331,9687,10475],0); -ELEMENTS[76064] = Fluid3D([2408,2703,2728,2415],0); -ELEMENTS[76065] = Fluid3D([8133,8710,8758,8623],0); -ELEMENTS[76066] = Fluid3D([14760,15291,15374,15594],0); -ELEMENTS[76067] = Fluid3D([2357,2448,2518,2346],0); -ELEMENTS[76068] = Fluid3D([4170,3942,4584,4166],0); -ELEMENTS[76069] = Fluid3D([7062,7040,7692,6457],0); -ELEMENTS[76070] = Fluid3D([9857,9655,9000,8721],0); -ELEMENTS[76071] = Fluid3D([8819,8035,8202,9151],0); -ELEMENTS[76072] = Fluid3D([5527,5957,5079,5335],0); -ELEMENTS[76073] = Fluid3D([13346,13993,14385,13961],0); -ELEMENTS[76074] = Fluid3D([13346,13993,13961,13858],0); -ELEMENTS[76075] = Fluid3D([5766,6027,6519,6767],0); -ELEMENTS[76076] = Fluid3D([7266,7181,6950,6495],0); -ELEMENTS[76077] = Fluid3D([13879,13157,13272,13337],0); -ELEMENTS[76078] = Fluid3D([11460,10541,11866,11374],0); -ELEMENTS[76079] = Fluid3D([12916,13226,13344,13950],0); -ELEMENTS[76080] = Fluid3D([18048,18056,18352,18312],0); -ELEMENTS[76081] = Fluid3D([10883,10637,9894,11045],0); -ELEMENTS[76082] = Fluid3D([4306,3848,4029,3656],0); -ELEMENTS[76083] = Fluid3D([9659,8808,9860,9351],0); -ELEMENTS[76084] = Fluid3D([9659,8808,9351,9573],0); -ELEMENTS[76085] = Fluid3D([2232,2365,2401,2130],0); -ELEMENTS[76086] = Fluid3D([16109,16429,15831,15677],0); -ELEMENTS[76087] = Fluid3D([13490,13586,13955,14444],0); -ELEMENTS[76088] = Fluid3D([5283,5393,5921,5781],0); -ELEMENTS[76089] = Fluid3D([16912,17106,17092,16821],0); -ELEMENTS[76090] = Fluid3D([16912,17106,16821,16366],0); -ELEMENTS[76091] = Fluid3D([17718,17396,17516,17699],0); -ELEMENTS[76092] = Fluid3D([9936,10447,10181,9697],0); -ELEMENTS[76093] = Fluid3D([5834,6639,6682,6338],0); -ELEMENTS[76094] = Fluid3D([5320,4928,5084,5760],0); -ELEMENTS[76095] = Fluid3D([13419,12960,14135,14148],0); -ELEMENTS[76096] = Fluid3D([3730,3507,3431,3074],0); -ELEMENTS[76097] = Fluid3D([6662,6736,7200,7777],0); -ELEMENTS[76098] = Fluid3D([8219,7390,7447,8007],0); -ELEMENTS[76099] = Fluid3D([14946,14883,14358,13900],0); -ELEMENTS[76100] = Fluid3D([2845,2630,2941,3191],0); -ELEMENTS[76101] = Fluid3D([3826,3467,3560,3676],0); -ELEMENTS[76102] = Fluid3D([4454,5055,5141,5222],0); -ELEMENTS[76103] = Fluid3D([5055,5141,5222,5964],0); -ELEMENTS[76104] = Fluid3D([13316,13681,14438,14258],0); -ELEMENTS[76105] = Fluid3D([3174,3537,3597,3751],0); -ELEMENTS[76106] = Fluid3D([18678,18681,18680,18650],0); -ELEMENTS[76107] = Fluid3D([7762,7470,8426,7594],0); -ELEMENTS[76108] = Fluid3D([7780,7771,7234,6467],0); -ELEMENTS[76109] = Fluid3D([6319,5545,5855,5581],0); -ELEMENTS[76110] = Fluid3D([5620,5705,5379,4873],0); -ELEMENTS[76111] = Fluid3D([14321,14617,14973,15175],0); -ELEMENTS[76112] = Fluid3D([13268,12645,12719,12761],0); -ELEMENTS[76113] = Fluid3D([7747,6802,7126,6608],0); -ELEMENTS[76114] = Fluid3D([8751,8233,7866,9001],0); -ELEMENTS[76115] = Fluid3D([16498,16586,16439,15965],0); -ELEMENTS[76116] = Fluid3D([6512,6519,7277,7036],0); -ELEMENTS[76117] = Fluid3D([6512,6519,7036,6767],0); -ELEMENTS[76118] = Fluid3D([10440,10262,11575,11374],0); -ELEMENTS[76119] = Fluid3D([10009,10624,10811,9853],0); -ELEMENTS[76120] = Fluid3D([10009,10624,9853,9677],0); -ELEMENTS[76121] = Fluid3D([11203,12162,11392,11799],0); -ELEMENTS[76122] = Fluid3D([17391,17185,16936,17008],0); -ELEMENTS[76123] = Fluid3D([7586,8035,8202,7147],0); -ELEMENTS[76124] = Fluid3D([15110,14654,15715,15141],0); -ELEMENTS[76125] = Fluid3D([10742,10451,12082,12252],0); -ELEMENTS[76126] = Fluid3D([6184,5824,6185,6520],0); -ELEMENTS[76127] = Fluid3D([12448,12501,13038,13483],0); -ELEMENTS[76128] = Fluid3D([3927,4101,4141,4743],0); -ELEMENTS[76129] = Fluid3D([9556,8735,9244,9427],0); -ELEMENTS[76130] = Fluid3D([13907,13936,14780,13702],0); -ELEMENTS[76131] = Fluid3D([15340,15829,15524,14821],0); -ELEMENTS[76132] = Fluid3D([6515,5821,7031,6531],0); -ELEMENTS[76133] = Fluid3D([11308,10560,9712,10539],0); -ELEMENTS[76134] = Fluid3D([9966,10382,10363,11316],0); -ELEMENTS[76135] = Fluid3D([18185,18267,18393,18483],0); -ELEMENTS[76136] = Fluid3D([17920,17992,18209,18027],0); -ELEMENTS[76137] = Fluid3D([9905,9753,10456,9265],0); -ELEMENTS[76138] = Fluid3D([8294,8246,7236,7344],0); -ELEMENTS[76139] = Fluid3D([12675,12524,11950,11386],0); -ELEMENTS[76140] = Fluid3D([11730,12504,12979,12237],0); -ELEMENTS[76141] = Fluid3D([16156,15435,15769,16076],0); -ELEMENTS[76142] = Fluid3D([16869,16426,16500,16858],0); -ELEMENTS[76143] = Fluid3D([17724,17688,17914,18094],0); -ELEMENTS[76144] = Fluid3D([3922,3820,4375,3878],0); -ELEMENTS[76145] = Fluid3D([4816,5328,5014,4405],0); -ELEMENTS[76146] = Fluid3D([3334,2986,3215,3415],0); -ELEMENTS[76147] = Fluid3D([14637,14856,13957,14086],0); -ELEMENTS[76148] = Fluid3D([7218,7954,7725,7609],0); -ELEMENTS[76149] = Fluid3D([7954,7725,7609,8556],0); -ELEMENTS[76150] = Fluid3D([7954,7725,8556,8792],0); -ELEMENTS[76151] = Fluid3D([8734,8709,9054,7811],0); -ELEMENTS[76152] = Fluid3D([10091,10020,10398,9392],0); -ELEMENTS[76153] = Fluid3D([15643,15935,15493,15973],0); -ELEMENTS[76154] = Fluid3D([13466,12911,12038,12664],0); -ELEMENTS[76155] = Fluid3D([8068,8692,8639,8858],0); -ELEMENTS[76156] = Fluid3D([9616,9546,8194,8949],0); -ELEMENTS[76157] = Fluid3D([9616,9546,8949,9792],0); -ELEMENTS[76158] = Fluid3D([9546,8949,9792,9130],0); -ELEMENTS[76159] = Fluid3D([8949,9616,9792,8788],0); -ELEMENTS[76160] = Fluid3D([9792,8949,8788,8165],0); -ELEMENTS[76161] = Fluid3D([8949,8788,8165,8852],0); -ELEMENTS[76162] = Fluid3D([8949,8788,8852,9616],0); -ELEMENTS[76163] = Fluid3D([8852,8949,9616,8194],0); -ELEMENTS[76164] = Fluid3D([8949,9792,9130,8165],0); -ELEMENTS[76165] = Fluid3D([9130,8949,8165,9546],0); -ELEMENTS[76166] = Fluid3D([8788,9792,8165,9130],0); -ELEMENTS[76167] = Fluid3D([15182,14061,14579,14937],0); -ELEMENTS[76168] = Fluid3D([18630,18647,18565,18641],0); -ELEMENTS[76169] = Fluid3D([2739,2970,2800,3116],0); -ELEMENTS[76170] = Fluid3D([2859,2801,3285,3157],0); -ELEMENTS[76171] = Fluid3D([11196,11866,12624,11947],0); -ELEMENTS[76172] = Fluid3D([7652,8478,7889,7849],0); -ELEMENTS[76173] = Fluid3D([8478,7889,7849,8997],0); -ELEMENTS[76174] = Fluid3D([14772,15298,15643,15278],0); -ELEMENTS[76175] = Fluid3D([7653,7147,6711,6918],0); -ELEMENTS[76176] = Fluid3D([17111,16997,16608,16498],0); -ELEMENTS[76177] = Fluid3D([9509,9518,10737,10719],0); -ELEMENTS[76178] = Fluid3D([3209,3430,3743,3820],0); -ELEMENTS[76179] = Fluid3D([3430,3743,3820,3878],0); -ELEMENTS[76180] = Fluid3D([11887,11478,11395,12658],0); -ELEMENTS[76181] = Fluid3D([16443,16366,16063,16821],0); -ELEMENTS[76182] = Fluid3D([16443,16366,16821,17106],0); -ELEMENTS[76183] = Fluid3D([2498,2674,2518,2948],0); -ELEMENTS[76184] = Fluid3D([9308,9640,8753,9673],0); -ELEMENTS[76185] = Fluid3D([18290,18394,18517,18307],0); -ELEMENTS[76186] = Fluid3D([7218,7954,7609,7996],0); -ELEMENTS[76187] = Fluid3D([6515,6148,5821,5711],0); -ELEMENTS[76188] = Fluid3D([6066,6372,6553,6669],0); -ELEMENTS[76189] = Fluid3D([10096,9153,9231,9885],0); -ELEMENTS[76190] = Fluid3D([2898,2751,2714,2914],0); -ELEMENTS[76191] = Fluid3D([15022,14300,14598,15535],0); -ELEMENTS[76192] = Fluid3D([12033,11703,12760,11581],0); -ELEMENTS[76193] = Fluid3D([11693,12656,11387,12441],0); -ELEMENTS[76194] = Fluid3D([14251,13612,13848,14029],0); -ELEMENTS[76195] = Fluid3D([2664,2683,2718,3077],0); -ELEMENTS[76196] = Fluid3D([7454,8223,8439,8372],0); -ELEMENTS[76197] = Fluid3D([16693,16798,17145,16601],0); -ELEMENTS[76198] = Fluid3D([7629,7040,7431,7692],0); -ELEMENTS[76199] = Fluid3D([8096,8116,7831,6985],0); -ELEMENTS[76200] = Fluid3D([17485,17699,17872,17415],0); -ELEMENTS[76201] = Fluid3D([13028,13614,12747,12403],0); -ELEMENTS[76202] = Fluid3D([13374,13876,12979,14373],0); -ELEMENTS[76203] = Fluid3D([16317,15897,16140,15557],0); -ELEMENTS[76204] = Fluid3D([18314,18278,18012,18186],0); -ELEMENTS[76205] = Fluid3D([6808,7362,7275,6350],0); -ELEMENTS[76206] = Fluid3D([17688,17675,17462,17914],0); -ELEMENTS[76207] = Fluid3D([4768,4110,4700,4128],0); -ELEMENTS[76208] = Fluid3D([8006,7472,7250,7353],0); -ELEMENTS[76209] = Fluid3D([15429,15137,15082,15814],0); -ELEMENTS[76210] = Fluid3D([10430,11325,9966,10813],0); -ELEMENTS[76211] = Fluid3D([11118,11823,12227,11336],0); -ELEMENTS[76212] = Fluid3D([12001,12020,12881,11387],0); -ELEMENTS[76213] = Fluid3D([18695,18691,18698,18699],0); -ELEMENTS[76214] = Fluid3D([18691,18698,18699,18696],0); -ELEMENTS[76215] = Fluid3D([18695,18691,18699,18696],0); -ELEMENTS[76216] = Fluid3D([12370,11925,12722,13209],0); -ELEMENTS[76217] = Fluid3D([18570,18523,18393,18354],0); -ELEMENTS[76218] = Fluid3D([18523,18393,18354,18408],0); -ELEMENTS[76219] = Fluid3D([7010,6638,6797,7614],0); -ELEMENTS[76220] = Fluid3D([2775,2714,2914,3124],0); -ELEMENTS[76221] = Fluid3D([3271,3578,2955,3140],0); -ELEMENTS[76222] = Fluid3D([17285,17117,17050,17158],0); -ELEMENTS[76223] = Fluid3D([13526,13791,12627,13660],0); -ELEMENTS[76224] = Fluid3D([16504,17014,17136,16898],0); -ELEMENTS[76225] = Fluid3D([13657,12843,12876,12745],0); -ELEMENTS[76226] = Fluid3D([4781,4703,4181,4754],0); -ELEMENTS[76227] = Fluid3D([12641,12311,12760,13616],0); -ELEMENTS[76228] = Fluid3D([6951,7579,7511,6636],0); -ELEMENTS[76229] = Fluid3D([10750,10031,10814,11298],0); -ELEMENTS[76230] = Fluid3D([6651,6244,5896,5912],0); -ELEMENTS[76231] = Fluid3D([5232,4664,5055,5141],0); -ELEMENTS[76232] = Fluid3D([5055,5288,5222,4454],0); -ELEMENTS[76233] = Fluid3D([5896,6651,5912,5964],0); -ELEMENTS[76234] = Fluid3D([5912,6135,5619,5964],0); -ELEMENTS[76235] = Fluid3D([5127,4950,5288,4664],0); -ELEMENTS[76236] = Fluid3D([5222,4704,5141,4454],0); -ELEMENTS[76237] = Fluid3D([4420,4381,4664,4950],0); -ELEMENTS[76238] = Fluid3D([5232,5912,5619,5964],0); -ELEMENTS[76239] = Fluid3D([4664,4454,4487,5288],0); -ELEMENTS[76240] = Fluid3D([5055,5288,5232,5964],0); -ELEMENTS[76241] = Fluid3D([6651,6244,5912,6135],0); -ELEMENTS[76242] = Fluid3D([4420,4162,4487,4664],0); -ELEMENTS[76243] = Fluid3D([5055,5232,5141,5964],0); -ELEMENTS[76244] = Fluid3D([5964,5896,5232,5912],0); -ELEMENTS[76245] = Fluid3D([5896,5232,5912,6244],0); -ELEMENTS[76246] = Fluid3D([4487,4454,3980,4309],0); -ELEMENTS[76247] = Fluid3D([5912,5554,6244,5232],0); -ELEMENTS[76248] = Fluid3D([6651,5912,5964,6135],0); -ELEMENTS[76249] = Fluid3D([4664,4420,4950,4831],0); -ELEMENTS[76250] = Fluid3D([4420,4950,4831,4944],0); -ELEMENTS[76251] = Fluid3D([4831,4420,4944,4487],0); -ELEMENTS[76252] = Fluid3D([4944,4831,4487,5288],0); -ELEMENTS[76253] = Fluid3D([4944,4831,5288,4950],0); -ELEMENTS[76254] = Fluid3D([4831,4487,5288,4664],0); -ELEMENTS[76255] = Fluid3D([4831,5288,4950,4664],0); -ELEMENTS[76256] = Fluid3D([4831,4420,4487,4664],0); -ELEMENTS[76257] = Fluid3D([5141,5619,5964,5232],0); -ELEMENTS[76258] = Fluid3D([5766,6512,6247,6519],0); -ELEMENTS[76259] = Fluid3D([10405,10637,11768,11861],0); -ELEMENTS[76260] = Fluid3D([15954,15606,15121,15438],0); -ELEMENTS[76261] = Fluid3D([5005,4889,4603,4302],0); -ELEMENTS[76262] = Fluid3D([14355,15072,14025,14764],0); -ELEMENTS[76263] = Fluid3D([9487,8531,9504,8540],0); -ELEMENTS[76264] = Fluid3D([7717,8048,7489,6988],0); -ELEMENTS[76265] = Fluid3D([14310,13976,14916,13997],0); -ELEMENTS[76266] = Fluid3D([10805,10533,10535,11826],0); -ELEMENTS[76267] = Fluid3D([5509,5476,6044,5391],0); -ELEMENTS[76268] = Fluid3D([5869,5255,5310,6165],0); -ELEMENTS[76269] = Fluid3D([6985,6875,7831,7785],0); -ELEMENTS[76270] = Fluid3D([7644,7826,8927,8789],0); -ELEMENTS[76271] = Fluid3D([9139,8230,8995,9090],0); -ELEMENTS[76272] = Fluid3D([6741,6970,7888,7283],0); -ELEMENTS[76273] = Fluid3D([12138,12663,12281,11495],0); -ELEMENTS[76274] = Fluid3D([12570,11814,12617,11289],0); -ELEMENTS[76275] = Fluid3D([5342,5997,5664,6109],0); -ELEMENTS[76276] = Fluid3D([6113,5719,6718,5985],0); -ELEMENTS[76277] = Fluid3D([8756,8483,8056,8807],0); -ELEMENTS[76278] = Fluid3D([9566,9434,8832,8151],0); -ELEMENTS[76279] = Fluid3D([8596,9258,8631,8861],0); -ELEMENTS[76280] = Fluid3D([3554,3433,3933,4118],0); -ELEMENTS[76281] = Fluid3D([14481,13737,13842,14863],0); -ELEMENTS[76282] = Fluid3D([10020,10091,10721,9786],0); -ELEMENTS[76283] = Fluid3D([10020,10091,9786,8614],0); -ELEMENTS[76284] = Fluid3D([10721,10020,9786,9411],0); -ELEMENTS[76285] = Fluid3D([10020,9786,9411,8675],0); -ELEMENTS[76286] = Fluid3D([10020,9786,8675,8614],0); -ELEMENTS[76287] = Fluid3D([12241,11853,11445,12734],0); -ELEMENTS[76288] = Fluid3D([13563,13877,14131,14713],0); -ELEMENTS[76289] = Fluid3D([4744,5168,4516,4672],0); -ELEMENTS[76290] = Fluid3D([6926,6583,6028,6178],0); -ELEMENTS[76291] = Fluid3D([2075,2319,2116,2250],0); -ELEMENTS[76292] = Fluid3D([2973,2936,3383,3204],0); -ELEMENTS[76293] = Fluid3D([6901,5924,6689,5978],0); -ELEMENTS[76294] = Fluid3D([6901,5924,5978,6661],0); -ELEMENTS[76295] = Fluid3D([11779,12476,11572,12032],0); -ELEMENTS[76296] = Fluid3D([8485,9131,9286,8124],0); -ELEMENTS[76297] = Fluid3D([8485,9131,8124,7595],0); -ELEMENTS[76298] = Fluid3D([12250,13028,11634,12590],0); -ELEMENTS[76299] = Fluid3D([12250,13028,12590,12243],0); -ELEMENTS[76300] = Fluid3D([6024,5242,5751,5658],0); -ELEMENTS[76301] = Fluid3D([3489,3894,3618,3814],0); -ELEMENTS[76302] = Fluid3D([7457,8372,7181,7665],0); -ELEMENTS[76303] = Fluid3D([4143,4039,3982,4206],0); -ELEMENTS[76304] = Fluid3D([17084,17240,17077,17525],0); -ELEMENTS[76305] = Fluid3D([17230,17246,17234,17630],0); -ELEMENTS[76306] = Fluid3D([15051,15174,14414,15305],0); -ELEMENTS[76307] = Fluid3D([17313,17155,16719,16750],0); -ELEMENTS[76308] = Fluid3D([7457,7538,7454,6618],0); -ELEMENTS[76309] = Fluid3D([18270,18354,18112,18267],0); -ELEMENTS[76310] = Fluid3D([4810,4506,4286,4101],0); -ELEMENTS[76311] = Fluid3D([3367,3213,3204,3383],0); -ELEMENTS[76312] = Fluid3D([11443,10269,11256,11391],0); -ELEMENTS[76313] = Fluid3D([2250,2501,2407,2262],0); -ELEMENTS[76314] = Fluid3D([2501,2407,2262,2598],0); -ELEMENTS[76315] = Fluid3D([2501,2407,2598,2910],0); -ELEMENTS[76316] = Fluid3D([9084,9444,8231,8452],0); -ELEMENTS[76317] = Fluid3D([14000,14626,14355,13766],0); -ELEMENTS[76318] = Fluid3D([16214,16635,16873,16251],0); -ELEMENTS[76319] = Fluid3D([5319,5400,5671,5028],0); -ELEMENTS[76320] = Fluid3D([8190,7189,8353,7880],0); -ELEMENTS[76321] = Fluid3D([8682,9549,8910,8946],0); -ELEMENTS[76322] = Fluid3D([8682,9549,8946,8623],0); -ELEMENTS[76323] = Fluid3D([9416,9176,10182,10821],0); -ELEMENTS[76324] = Fluid3D([11829,11824,12240,11298],0); -ELEMENTS[76325] = Fluid3D([13735,14227,14767,14662],0); -ELEMENTS[76326] = Fluid3D([10543,10830,9527,9812],0); -ELEMENTS[76327] = Fluid3D([8496,9231,9151,9153],0); -ELEMENTS[76328] = Fluid3D([3565,3667,3681,4296],0); -ELEMENTS[76329] = Fluid3D([16274,16159,16624,16868],0); -ELEMENTS[76330] = Fluid3D([7199,6885,7775,7981],0); -ELEMENTS[76331] = Fluid3D([17660,17767,17885,18120],0); -ELEMENTS[76332] = Fluid3D([17892,18175,17972,17638],0); -ELEMENTS[76333] = Fluid3D([3542,3484,3117,3299],0); -ELEMENTS[76334] = Fluid3D([3557,3310,3881,3226],0); -ELEMENTS[76335] = Fluid3D([10544,10287,10344,9375],0); -ELEMENTS[76336] = Fluid3D([2781,2509,2988,2825],0); -ELEMENTS[76337] = Fluid3D([3081,2744,3206,2872],0); -ELEMENTS[76338] = Fluid3D([11432,10595,10848,10894],0); -ELEMENTS[76339] = Fluid3D([8507,8614,7856,8898],0); -ELEMENTS[76340] = Fluid3D([8367,8272,9257,8623],0); -ELEMENTS[76341] = Fluid3D([3817,4196,3619,3640],0); -ELEMENTS[76342] = Fluid3D([10613,9715,9327,10383],0); -ELEMENTS[76343] = Fluid3D([11187,11783,10434,11386],0); -ELEMENTS[76344] = Fluid3D([8471,8430,7784,9179],0); -ELEMENTS[76345] = Fluid3D([18414,18571,18431,18596],0); -ELEMENTS[76346] = Fluid3D([9499,9753,9265,10456],0); -ELEMENTS[76347] = Fluid3D([3867,4498,4394,4015],0); -ELEMENTS[76348] = Fluid3D([14620,14124,13715,13780],0); -ELEMENTS[76349] = Fluid3D([12534,11567,12711,11229],0); -ELEMENTS[76350] = Fluid3D([13731,14350,14632,13814],0); -ELEMENTS[76351] = Fluid3D([4948,5650,5153,5043],0); -ELEMENTS[76352] = Fluid3D([4948,5650,5043,5498],0); -ELEMENTS[76353] = Fluid3D([12738,12603,12503,13858],0); -ELEMENTS[76354] = Fluid3D([5816,6728,6438,6346],0); -ELEMENTS[76355] = Fluid3D([9446,9209,9030,9734],0); -ELEMENTS[76356] = Fluid3D([12351,11776,12783,13040],0); -ELEMENTS[76357] = Fluid3D([16692,16812,17115,17347],0); -ELEMENTS[76358] = Fluid3D([6259,5771,6615,5777],0); -ELEMENTS[76359] = Fluid3D([17453,17460,17781,17542],0); -ELEMENTS[76360] = Fluid3D([15235,14659,15242,15397],0); -ELEMENTS[76361] = Fluid3D([3089,3426,3386,3286],0); -ELEMENTS[76362] = Fluid3D([8646,8675,8614,7856],0); -ELEMENTS[76363] = Fluid3D([16443,16540,16497,15826],0); -ELEMENTS[76364] = Fluid3D([15095,14588,14808,14711],0); -ELEMENTS[76365] = Fluid3D([2980,2843,2547,2823],0); -ELEMENTS[76366] = Fluid3D([17876,18011,18232,18329],0); -ELEMENTS[76367] = Fluid3D([6311,7186,6542,6632],0); -ELEMENTS[76368] = Fluid3D([15762,16225,16558,15904],0); -ELEMENTS[76369] = Fluid3D([18412,18370,18553,18543],0); -ELEMENTS[76370] = Fluid3D([3672,4053,3546,3905],0); -ELEMENTS[76371] = Fluid3D([14849,15097,14564,14337],0); -ELEMENTS[76372] = Fluid3D([8867,7923,8015,8729],0); -ELEMENTS[76373] = Fluid3D([11647,12248,10812,10873],0); -ELEMENTS[76374] = Fluid3D([16053,16338,15683,16098],0); -ELEMENTS[76375] = Fluid3D([15954,16484,16177,16130],0); -ELEMENTS[76376] = Fluid3D([5158,5714,5338,4800],0); -ELEMENTS[76377] = Fluid3D([13027,13053,13579,14141],0); -ELEMENTS[76378] = Fluid3D([17424,17243,17008,16968],0); -ELEMENTS[76379] = Fluid3D([14946,14784,13985,14575],0); -ELEMENTS[76380] = Fluid3D([14784,13985,14575,13914],0); -ELEMENTS[76381] = Fluid3D([15030,15320,15285,15934],0); -ELEMENTS[76382] = Fluid3D([17605,17739,17734,18073],0); -ELEMENTS[76383] = Fluid3D([6697,7132,6349,5822],0); -ELEMENTS[76384] = Fluid3D([5848,6555,6965,6091],0); -ELEMENTS[76385] = Fluid3D([2851,3198,3135,2683],0); -ELEMENTS[76386] = Fluid3D([16611,16678,17197,17167],0); -ELEMENTS[76387] = Fluid3D([4037,3605,3948,3934],0); -ELEMENTS[76388] = Fluid3D([6862,7713,6893,7572],0); -ELEMENTS[76389] = Fluid3D([14382,13711,14532,13807],0); -ELEMENTS[76390] = Fluid3D([7396,8204,8605,7676],0); -ELEMENTS[76391] = Fluid3D([14179,13159,13023,14073],0); -ELEMENTS[76392] = Fluid3D([5562,4929,5329,5543],0); -ELEMENTS[76393] = Fluid3D([15092,15082,14721,14171],0); -ELEMENTS[76394] = Fluid3D([4542,4212,4040,3805],0); -ELEMENTS[76395] = Fluid3D([8737,9190,9620,9773],0); -ELEMENTS[76396] = Fluid3D([15551,15337,15111,14814],0); -ELEMENTS[76397] = Fluid3D([12764,12823,13977,13796],0); -ELEMENTS[76398] = Fluid3D([16980,17258,16789,17180],0); -ELEMENTS[76399] = Fluid3D([7914,7069,6875,7831],0); -ELEMENTS[76400] = Fluid3D([15755,15249,16027,15799],0); -ELEMENTS[76401] = Fluid3D([9115,9238,8816,8166],0); -ELEMENTS[76402] = Fluid3D([8721,8441,9000,9857],0); -ELEMENTS[76403] = Fluid3D([17299,17579,17040,17182],0); -ELEMENTS[76404] = Fluid3D([12607,12507,12554,13355],0); -ELEMENTS[76405] = Fluid3D([16986,17365,17009,16644],0); -ELEMENTS[76406] = Fluid3D([14023,14246,14696,14126],0); -ELEMENTS[76407] = Fluid3D([2187,2346,2144,2219],0); -ELEMENTS[76408] = Fluid3D([9709,9896,10896,10776],0); -ELEMENTS[76409] = Fluid3D([4112,3659,3782,3873],0); -ELEMENTS[76410] = Fluid3D([9113,8884,7880,7940],0); -ELEMENTS[76411] = Fluid3D([11275,10362,10845,9710],0); -ELEMENTS[76412] = Fluid3D([4913,4609,4074,4330],0); -ELEMENTS[76413] = Fluid3D([3955,3577,4094,3643],0); -ELEMENTS[76414] = Fluid3D([3955,3577,3643,4032],0); -ELEMENTS[76415] = Fluid3D([3955,3577,4032,3505],0); -ELEMENTS[76416] = Fluid3D([10775,10448,9888,10767],0); -ELEMENTS[76417] = Fluid3D([9856,9266,10403,9888],0); -ELEMENTS[76418] = Fluid3D([9888,9856,10346,10740],0); -ELEMENTS[76419] = Fluid3D([11211,11293,10403,10740],0); -ELEMENTS[76420] = Fluid3D([10403,11211,10740,11300],0); -ELEMENTS[76421] = Fluid3D([10740,10403,11300,10448],0); -ELEMENTS[76422] = Fluid3D([11300,10740,10448,10767],0); -ELEMENTS[76423] = Fluid3D([10740,10403,10448,9888],0); -ELEMENTS[76424] = Fluid3D([10767,11501,11451,11014],0); -ELEMENTS[76425] = Fluid3D([10403,9856,9888,10740],0); -ELEMENTS[76426] = Fluid3D([10448,10740,9888,10767],0); -ELEMENTS[76427] = Fluid3D([11293,10403,10740,10112],0); -ELEMENTS[76428] = Fluid3D([11451,11594,10767,11300],0); -ELEMENTS[76429] = Fluid3D([10366,11014,10346,11293],0); -ELEMENTS[76430] = Fluid3D([9856,10366,10346,11293],0); -ELEMENTS[76431] = Fluid3D([10403,10740,10112,9856],0); -ELEMENTS[76432] = Fluid3D([10740,11293,10112,9856],0); -ELEMENTS[76433] = Fluid3D([10740,11293,9856,10346],0); -ELEMENTS[76434] = Fluid3D([10740,11293,10346,11451],0); -ELEMENTS[76435] = Fluid3D([11211,10740,11300,11451],0); -ELEMENTS[76436] = Fluid3D([11211,11293,10740,11451],0); -ELEMENTS[76437] = Fluid3D([10346,10740,11451,10767],0); -ELEMENTS[76438] = Fluid3D([10740,11451,10767,11300],0); -ELEMENTS[76439] = Fluid3D([11451,10346,10767,11014],0); -ELEMENTS[76440] = Fluid3D([10346,10740,10767,9888],0); -ELEMENTS[76441] = Fluid3D([11451,12238,11293,11014],0); -ELEMENTS[76442] = Fluid3D([11300,10448,10775,10767],0); -ELEMENTS[76443] = Fluid3D([11501,11954,11451,12238],0); -ELEMENTS[76444] = Fluid3D([11451,11501,12238,11014],0); -ELEMENTS[76445] = Fluid3D([9025,8335,8145,9521],0); -ELEMENTS[76446] = Fluid3D([9025,8335,9521,8987],0); -ELEMENTS[76447] = Fluid3D([11406,11884,11172,10994],0); -ELEMENTS[76448] = Fluid3D([9413,8503,8759,8756],0); -ELEMENTS[76449] = Fluid3D([9413,8503,8756,9260],0); -ELEMENTS[76450] = Fluid3D([8503,8756,9260,8635],0); -ELEMENTS[76451] = Fluid3D([8636,8729,8720,9612],0); -ELEMENTS[76452] = Fluid3D([18324,18288,18222,18099],0); -ELEMENTS[76453] = Fluid3D([12633,12239,13320,12585],0); -ELEMENTS[76454] = Fluid3D([13807,14566,14532,14382],0); -ELEMENTS[76455] = Fluid3D([15118,14562,15433,15328],0); -ELEMENTS[76456] = Fluid3D([7408,6803,7693,7869],0); -ELEMENTS[76457] = Fluid3D([11866,12762,11947,11682],0); -ELEMENTS[76458] = Fluid3D([2776,3071,2938,2689],0); -ELEMENTS[76459] = Fluid3D([5824,5258,5298,5109],0); -ELEMENTS[76460] = Fluid3D([15401,15205,15585,16007],0); -ELEMENTS[76461] = Fluid3D([1616,1543,1613,1671],0); -ELEMENTS[76462] = Fluid3D([1613,1616,1671,1746],0); -ELEMENTS[76463] = Fluid3D([8869,8614,9392,10020],0); -ELEMENTS[76464] = Fluid3D([5555,4959,5508,4994],0); -ELEMENTS[76465] = Fluid3D([17349,17348,17589,17066],0); -ELEMENTS[76466] = Fluid3D([13073,12727,11921,11743],0); -ELEMENTS[76467] = Fluid3D([9735,10488,10056,9936],0); -ELEMENTS[76468] = Fluid3D([3951,3714,3310,3881],0); -ELEMENTS[76469] = Fluid3D([7056,7817,7820,7706],0); -ELEMENTS[76470] = Fluid3D([16451,16064,15994,16121],0); -ELEMENTS[76471] = Fluid3D([9932,10008,10821,9176],0); -ELEMENTS[76472] = Fluid3D([5602,5798,5486,6248],0); -ELEMENTS[76473] = Fluid3D([4019,4253,3630,3815],0); -ELEMENTS[76474] = Fluid3D([16257,15873,16480,16737],0); -ELEMENTS[76475] = Fluid3D([14696,14618,14023,13295],0); -ELEMENTS[76476] = Fluid3D([3026,2935,3273,3497],0); -ELEMENTS[76477] = Fluid3D([13952,13823,14612,13828],0); -ELEMENTS[76478] = Fluid3D([12815,12547,13400,13491],0); -ELEMENTS[76479] = Fluid3D([9333,9936,8452,9697],0); -ELEMENTS[76480] = Fluid3D([4753,4364,4774,4832],0); -ELEMENTS[76481] = Fluid3D([9666,9030,9927,9734],0); -ELEMENTS[76482] = Fluid3D([11393,10369,11442,11620],0); -ELEMENTS[76483] = Fluid3D([16294,16201,16858,16966],0); -ELEMENTS[76484] = Fluid3D([6198,6204,5442,5627],0); -ELEMENTS[76485] = Fluid3D([15337,15551,14582,14814],0); -ELEMENTS[76486] = Fluid3D([9514,9971,10894,9929],0); -ELEMENTS[76487] = Fluid3D([15971,15991,15775,16372],0); -ELEMENTS[76488] = Fluid3D([13352,13606,14376,14449],0); -ELEMENTS[76489] = Fluid3D([14874,15282,15546,15800],0); -ELEMENTS[76490] = Fluid3D([12218,11725,11034,10865],0); -ELEMENTS[76491] = Fluid3D([11725,11034,10865,10800],0); -ELEMENTS[76492] = Fluid3D([7016,6449,5989,6714],0); -ELEMENTS[76493] = Fluid3D([6479,6376,7411,7661],0); -ELEMENTS[76494] = Fluid3D([3692,4223,3813,4300],0); -ELEMENTS[76495] = Fluid3D([12302,11645,12212,12367],0); -ELEMENTS[76496] = Fluid3D([10512,10180,9791,9284],0); -ELEMENTS[76497] = Fluid3D([9791,10512,9284,10585],0); -ELEMENTS[76498] = Fluid3D([3198,2851,2664,2683],0); -ELEMENTS[76499] = Fluid3D([15199,15345,14873,14837],0); -ELEMENTS[76500] = Fluid3D([3306,3370,3561,3708],0); -ELEMENTS[76501] = Fluid3D([18474,18600,18524,18473],0); -ELEMENTS[76502] = Fluid3D([17727,17563,17668,17988],0); -ELEMENTS[76503] = Fluid3D([15303,14612,14977,14947],0); -ELEMENTS[76504] = Fluid3D([7603,7088,7882,8192],0); -ELEMENTS[76505] = Fluid3D([11687,11415,11614,10401],0); -ELEMENTS[76506] = Fluid3D([1932,2032,1911,2214],0); -ELEMENTS[76507] = Fluid3D([10512,11436,10180,11513],0); -ELEMENTS[76508] = Fluid3D([11693,11818,12656,12441],0); -ELEMENTS[76509] = Fluid3D([11818,12656,12441,12563],0); -ELEMENTS[76510] = Fluid3D([12690,11978,12702,11286],0); -ELEMENTS[76511] = Fluid3D([17937,17797,17511,17595],0); -ELEMENTS[76512] = Fluid3D([6512,6247,6519,6767],0); -ELEMENTS[76513] = Fluid3D([15865,15740,15267,14974],0); -ELEMENTS[76514] = Fluid3D([3057,2995,3037,2705],0); -ELEMENTS[76515] = Fluid3D([2801,2859,2750,3157],0); -ELEMENTS[76516] = Fluid3D([16242,15880,16483,16653],0); -ELEMENTS[76517] = Fluid3D([14539,15164,14540,14397],0); -ELEMENTS[76518] = Fluid3D([15449,14808,15183,15472],0); -ELEMENTS[76519] = Fluid3D([7188,8055,6936,7776],0); -ELEMENTS[76520] = Fluid3D([12896,12739,13321,13807],0); -ELEMENTS[76521] = Fluid3D([3072,2998,2948,2611],0); -ELEMENTS[76522] = Fluid3D([18666,18608,18632,18623],0); -ELEMENTS[76523] = Fluid3D([5433,5977,5522,5282],0); -ELEMENTS[76524] = Fluid3D([8587,9725,9226,8642],0); -ELEMENTS[76525] = Fluid3D([7814,6886,7163,6444],0); -ELEMENTS[76526] = Fluid3D([5516,5316,4815,5386],0); -ELEMENTS[76527] = Fluid3D([4487,4208,4886,4309],0); -ELEMENTS[76528] = Fluid3D([11880,12059,11914,12856],0); -ELEMENTS[76529] = Fluid3D([9117,8607,8289,7648],0); -ELEMENTS[76530] = Fluid3D([17221,17469,17333,17616],0); -ELEMENTS[76531] = Fluid3D([13648,13023,14073,14250],0); -ELEMENTS[76532] = Fluid3D([11240,10358,10860,9919],0); -ELEMENTS[76533] = Fluid3D([12417,13333,12673,13652],0); -ELEMENTS[76534] = Fluid3D([17590,17309,17564,17575],0); -ELEMENTS[76535] = Fluid3D([3044,2784,3072,2948],0); -ELEMENTS[76536] = Fluid3D([3044,2784,2948,2674],0); -ELEMENTS[76537] = Fluid3D([11156,11624,10922,11662],0); -ELEMENTS[76538] = Fluid3D([8882,9191,8961,8429],0); -ELEMENTS[76539] = Fluid3D([13906,14040,13100,13227],0); -ELEMENTS[76540] = Fluid3D([16073,15921,16525,15801],0); -ELEMENTS[76541] = Fluid3D([17437,17768,17291,17603],0); -ELEMENTS[76542] = Fluid3D([8891,9636,9187,8488],0); -ELEMENTS[76543] = Fluid3D([5165,4624,4958,5358],0); -ELEMENTS[76544] = Fluid3D([12478,13205,12639,12763],0); -ELEMENTS[76545] = Fluid3D([9630,9362,10160,10800],0); -ELEMENTS[76546] = Fluid3D([11249,11214,12441,12150],0); -ELEMENTS[76547] = Fluid3D([12441,11249,12150,11855],0); -ELEMENTS[76548] = Fluid3D([16689,17182,16922,17327],0); -ELEMENTS[76549] = Fluid3D([17280,17609,17339,17639],0); -ELEMENTS[76550] = Fluid3D([14582,14309,14814,15551],0); -ELEMENTS[76551] = Fluid3D([17550,17514,17888,17665],0); -ELEMENTS[76552] = Fluid3D([1919,1740,1870,1739],0); -ELEMENTS[76553] = Fluid3D([17310,17325,17214,16882],0); -ELEMENTS[76554] = Fluid3D([18103,18172,17810,17958],0); -ELEMENTS[76555] = Fluid3D([16496,16926,17083,16805],0); -ELEMENTS[76556] = Fluid3D([4909,4339,4375,5234],0); -ELEMENTS[76557] = Fluid3D([14738,14861,14657,13915],0); -ELEMENTS[76558] = Fluid3D([11073,11894,10778,11000],0); -ELEMENTS[76559] = Fluid3D([5561,5808,6283,5805],0); -ELEMENTS[76560] = Fluid3D([15891,16265,15755,16181],0); -ELEMENTS[76561] = Fluid3D([16443,16018,16540,15826],0); -ELEMENTS[76562] = Fluid3D([13203,13003,12684,12164],0); -ELEMENTS[76563] = Fluid3D([6146,5656,6583,5637],0); -ELEMENTS[76564] = Fluid3D([11771,11921,12727,11743],0); -ELEMENTS[76565] = Fluid3D([13467,13055,13980,14450],0); -ELEMENTS[76566] = Fluid3D([10569,11014,11366,10425],0); -ELEMENTS[76567] = Fluid3D([3295,3565,3320,3719],0); -ELEMENTS[76568] = Fluid3D([18510,18525,18431,18287],0); -ELEMENTS[76569] = Fluid3D([11255,12151,11455,11579],0); -ELEMENTS[76570] = Fluid3D([17050,16666,16660,17117],0); -ELEMENTS[76571] = Fluid3D([14217,13430,14538,13408],0); -ELEMENTS[76572] = Fluid3D([11216,11823,10372,11118],0); -ELEMENTS[76573] = Fluid3D([11216,11823,11118,11336],0); -ELEMENTS[76574] = Fluid3D([13657,13825,12745,12876],0); -ELEMENTS[76575] = Fluid3D([3148,3150,2687,2892],0); -ELEMENTS[76576] = Fluid3D([12120,12964,11976,12038],0); -ELEMENTS[76577] = Fluid3D([4166,4263,4758,4170],0); -ELEMENTS[76578] = Fluid3D([10669,10805,10535,11826],0); -ELEMENTS[76579] = Fluid3D([11736,10927,11357,11827],0); -ELEMENTS[76580] = Fluid3D([14360,13942,14538,14892],0); -ELEMENTS[76581] = Fluid3D([17565,17180,17060,17258],0); -ELEMENTS[76582] = Fluid3D([1671,1693,1803,1618],0); -ELEMENTS[76583] = Fluid3D([11579,10745,10766,10769],0); -ELEMENTS[76584] = Fluid3D([6690,6116,6982,7244],0); -ELEMENTS[76585] = Fluid3D([8550,8353,9517,8649],0); -ELEMENTS[76586] = Fluid3D([18486,18467,18559,18220],0); -ELEMENTS[76587] = Fluid3D([16376,16586,16014,15798],0); -ELEMENTS[76588] = Fluid3D([14096,13858,12894,12503],0); -ELEMENTS[76589] = Fluid3D([14626,14452,14355,13766],0); -ELEMENTS[76590] = Fluid3D([11608,11324,10252,10243],0); -ELEMENTS[76591] = Fluid3D([6660,6937,6132,6446],0); -ELEMENTS[76592] = Fluid3D([9051,9696,10540,9505],0); -ELEMENTS[76593] = Fluid3D([12113,11388,11901,11345],0); -ELEMENTS[76594] = Fluid3D([11662,11142,10626,10188],0); -ELEMENTS[76595] = Fluid3D([2772,2595,2725,2718],0); -ELEMENTS[76596] = Fluid3D([15546,15285,14769,15320],0); -ELEMENTS[76597] = Fluid3D([11579,12574,12436,11731],0); -ELEMENTS[76598] = Fluid3D([9521,8921,9173,8335],0); -ELEMENTS[76599] = Fluid3D([5222,4704,4454,4487],0); -ELEMENTS[76600] = Fluid3D([4704,4454,4487,4309],0); -ELEMENTS[76601] = Fluid3D([4454,5222,4487,5288],0); -ELEMENTS[76602] = Fluid3D([5379,5702,6293,6065],0); -ELEMENTS[76603] = Fluid3D([12102,12551,11895,11474],0); -ELEMENTS[76604] = Fluid3D([7991,6970,7888,7487],0); -ELEMENTS[76605] = Fluid3D([3913,3786,4101,4506],0); -ELEMENTS[76606] = Fluid3D([12690,12865,12405,11931],0); -ELEMENTS[76607] = Fluid3D([16329,15932,15369,15859],0); -ELEMENTS[76608] = Fluid3D([17085,16842,16422,16691],0); -ELEMENTS[76609] = Fluid3D([11314,12164,12034,11995],0); -ELEMENTS[76610] = Fluid3D([16763,17142,17392,17102],0); -ELEMENTS[76611] = Fluid3D([16763,17142,17102,17167],0); -ELEMENTS[76612] = Fluid3D([9546,8194,8949,8165],0); -ELEMENTS[76613] = Fluid3D([8194,8949,8165,8852],0); -ELEMENTS[76614] = Fluid3D([9776,9597,9208,8379],0); -ELEMENTS[76615] = Fluid3D([9005,9233,9457,10139],0); -ELEMENTS[76616] = Fluid3D([10031,10339,10969,11298],0); -ELEMENTS[76617] = Fluid3D([10339,10969,11298,11795],0); -ELEMENTS[76618] = Fluid3D([10969,10031,11298,10814],0); -ELEMENTS[76619] = Fluid3D([3234,3139,3339,2876],0); -ELEMENTS[76620] = Fluid3D([1942,2056,1928,1816],0); -ELEMENTS[76621] = Fluid3D([1942,2056,1816,1875],0); -ELEMENTS[76622] = Fluid3D([1816,1942,1875,2007],0); -ELEMENTS[76623] = Fluid3D([1839,1879,1804,2086],0); -ELEMENTS[76624] = Fluid3D([4294,4280,4893,4281],0); -ELEMENTS[76625] = Fluid3D([18280,18044,18277,17974],0); -ELEMENTS[76626] = Fluid3D([7614,7010,6527,6797],0); -ELEMENTS[76627] = Fluid3D([10587,11064,11524,10298],0); -ELEMENTS[76628] = Fluid3D([2859,2680,2963,3156],0); -ELEMENTS[76629] = Fluid3D([11236,11964,10424,11768],0); -ELEMENTS[76630] = Fluid3D([8610,9224,8367,9257],0); -ELEMENTS[76631] = Fluid3D([14140,13971,15055,14322],0); -ELEMENTS[76632] = Fluid3D([14140,13971,14322,13205],0); -ELEMENTS[76633] = Fluid3D([9393,10270,9653,9285],0); -ELEMENTS[76634] = Fluid3D([18103,18278,17877,18012],0); -ELEMENTS[76635] = Fluid3D([5335,5227,4731,4469],0); -ELEMENTS[76636] = Fluid3D([9407,9138,8081,8519],0); -ELEMENTS[76637] = Fluid3D([8573,8849,9902,9877],0); -ELEMENTS[76638] = Fluid3D([5743,5787,5889,5091],0); -ELEMENTS[76639] = Fluid3D([10746,10043,10268,10527],0); -ELEMENTS[76640] = Fluid3D([16440,16186,16953,16628],0); -ELEMENTS[76641] = Fluid3D([14618,14696,15556,15489],0); -ELEMENTS[76642] = Fluid3D([3982,4143,3874,3528],0); -ELEMENTS[76643] = Fluid3D([3611,3269,3441,3296],0); -ELEMENTS[76644] = Fluid3D([3848,3549,3471,3257],0); -ELEMENTS[76645] = Fluid3D([11054,10577,10562,11273],0); -ELEMENTS[76646] = Fluid3D([13601,13524,12963,12416],0); -ELEMENTS[76647] = Fluid3D([2357,2498,2518,2727],0); -ELEMENTS[76648] = Fluid3D([7069,6985,7831,8116],0); -ELEMENTS[76649] = Fluid3D([9448,10383,9327,9715],0); -ELEMENTS[76650] = Fluid3D([6797,6638,7538,7614],0); -ELEMENTS[76651] = Fluid3D([12907,13234,13794,14178],0); -ELEMENTS[76652] = Fluid3D([13116,13715,14323,14124],0); -ELEMENTS[76653] = Fluid3D([15886,16259,15381,15896],0); -ELEMENTS[76654] = Fluid3D([12088,11164,11774,12554],0); -ELEMENTS[76655] = Fluid3D([15492,14831,15134,15436],0); -ELEMENTS[76656] = Fluid3D([9547,8956,9829,9884],0); -ELEMENTS[76657] = Fluid3D([11721,11367,11162,12209],0); -ELEMENTS[76658] = Fluid3D([7640,7056,7820,7672],0); -ELEMENTS[76659] = Fluid3D([2689,3145,2890,3071],0); -ELEMENTS[76660] = Fluid3D([14024,14353,14461,13851],0); -ELEMENTS[76661] = Fluid3D([4619,4723,4475,4237],0); -ELEMENTS[76662] = Fluid3D([13320,13196,12633,12040],0); -ELEMENTS[76663] = Fluid3D([10558,9556,10284,10149],0); -ELEMENTS[76664] = Fluid3D([8648,9597,8997,8608],0); -ELEMENTS[76665] = Fluid3D([11984,11814,12617,12782],0); -ELEMENTS[76666] = Fluid3D([12684,12837,13203,12164],0); -ELEMENTS[76667] = Fluid3D([8217,7062,7972,7005],0); -ELEMENTS[76668] = Fluid3D([8934,7966,7983,8046],0); -ELEMENTS[76669] = Fluid3D([17138,16535,16705,16985],0); -ELEMENTS[76670] = Fluid3D([4562,4829,4731,5335],0); -ELEMENTS[76671] = Fluid3D([3476,3219,3570,3852],0); -ELEMENTS[76672] = Fluid3D([3554,3854,4118,4295],0); -ELEMENTS[76673] = Fluid3D([10794,10945,11050,10435],0); -ELEMENTS[76674] = Fluid3D([16731,16274,16150,16380],0); -ELEMENTS[76675] = Fluid3D([3222,3157,2750,2963],0); -ELEMENTS[76676] = Fluid3D([8055,7970,7520,6936],0); -ELEMENTS[76677] = Fluid3D([2261,2538,2550,2606],0); -ELEMENTS[76678] = Fluid3D([7692,7972,8820,7629],0); -ELEMENTS[76679] = Fluid3D([17873,17872,17415,17603],0); -ELEMENTS[76680] = Fluid3D([10091,9439,8614,9392],0); -ELEMENTS[76681] = Fluid3D([15838,16029,16339,15881],0); -ELEMENTS[76682] = Fluid3D([11306,11034,11257,12218],0); -ELEMENTS[76683] = Fluid3D([13245,12583,12985,12501],0); -ELEMENTS[76684] = Fluid3D([6163,6527,6298,6797],0); -ELEMENTS[76685] = Fluid3D([8497,8166,9238,8143],0); -ELEMENTS[76686] = Fluid3D([8497,8166,8143,7566],0); -ELEMENTS[76687] = Fluid3D([11921,12232,12727,13242],0); -ELEMENTS[76688] = Fluid3D([15461,15183,16114,15895],0); -ELEMENTS[76689] = Fluid3D([7599,6707,7026,7582],0); -ELEMENTS[76690] = Fluid3D([17980,18132,18333,18252],0); -ELEMENTS[76691] = Fluid3D([15390,14941,15777,15705],0); -ELEMENTS[76692] = Fluid3D([18641,18624,18565,18630],0); -ELEMENTS[76693] = Fluid3D([17287,17055,16718,17100],0); -ELEMENTS[76694] = Fluid3D([7540,7968,8606,8054],0); -ELEMENTS[76695] = Fluid3D([10407,10117,10109,11447],0); -ELEMENTS[76696] = Fluid3D([10520,11044,11534,10116],0); -ELEMENTS[76697] = Fluid3D([17219,17117,16599,16666],0); -ELEMENTS[76698] = Fluid3D([13202,13262,13314,12324],0); -ELEMENTS[76699] = Fluid3D([5711,5369,4956,4851],0); -ELEMENTS[76700] = Fluid3D([12038,11976,13106,12964],0); -ELEMENTS[76701] = Fluid3D([3285,3590,3187,3560],0); -ELEMENTS[76702] = Fluid3D([4087,3897,3958,3458],0); -ELEMENTS[76703] = Fluid3D([5077,5556,5880,5143],0); -ELEMENTS[76704] = Fluid3D([5077,5556,5143,5419],0); -ELEMENTS[76705] = Fluid3D([15248,14447,14691,15193],0); -ELEMENTS[76706] = Fluid3D([14691,15248,15193,15386],0); -ELEMENTS[76707] = Fluid3D([3295,3619,3605,3640],0); -ELEMENTS[76708] = Fluid3D([4404,5045,4375,5234],0); -ELEMENTS[76709] = Fluid3D([15852,15165,15674,15188],0); -ELEMENTS[76710] = Fluid3D([12481,13005,12047,12414],0); -ELEMENTS[76711] = Fluid3D([12481,13005,12414,13610],0); -ELEMENTS[76712] = Fluid3D([16180,16413,16539,15717],0); -ELEMENTS[76713] = Fluid3D([13334,13149,13321,12652],0); -ELEMENTS[76714] = Fluid3D([13321,13334,12652,14284],0); -ELEMENTS[76715] = Fluid3D([13334,13149,12652,11952],0); -ELEMENTS[76716] = Fluid3D([12987,12308,12845,11692],0); -ELEMENTS[76717] = Fluid3D([3895,4430,3967,4372],0); -ELEMENTS[76718] = Fluid3D([4609,4998,4250,4410],0); -ELEMENTS[76719] = Fluid3D([14258,14464,14438,13316],0); -ELEMENTS[76720] = Fluid3D([6467,7234,7122,7771],0); -ELEMENTS[76721] = Fluid3D([4930,4832,4425,5195],0); -ELEMENTS[76722] = Fluid3D([4930,4832,5195,5685],0); -ELEMENTS[76723] = Fluid3D([13763,13957,13288,13972],0); -ELEMENTS[76724] = Fluid3D([3982,3560,4359,3826],0); -ELEMENTS[76725] = Fluid3D([15077,15489,14816,14085],0); -ELEMENTS[76726] = Fluid3D([2683,2695,3135,2851],0); -ELEMENTS[76727] = Fluid3D([8621,9546,9130,8165],0); -ELEMENTS[76728] = Fluid3D([16024,15737,16327,16601],0); -ELEMENTS[76729] = Fluid3D([18486,18438,18220,18559],0); -ELEMENTS[76730] = Fluid3D([14881,15728,15062,15470],0); -ELEMENTS[76731] = Fluid3D([13602,12764,13977,14295],0); -ELEMENTS[76732] = Fluid3D([11046,11755,12222,12330],0); -ELEMENTS[76733] = Fluid3D([2038,1870,1985,2019],0); -ELEMENTS[76734] = Fluid3D([14924,14481,14760,13883],0); -ELEMENTS[76735] = Fluid3D([17349,17335,16880,17066],0); -ELEMENTS[76736] = Fluid3D([13697,14329,13859,14551],0); -ELEMENTS[76737] = Fluid3D([12714,13637,13783,12809],0); -ELEMENTS[76738] = Fluid3D([2744,2741,2778,2460],0); -ELEMENTS[76739] = Fluid3D([2744,2741,2460,2365],0); -ELEMENTS[76740] = Fluid3D([18468,18442,18243,18191],0); -ELEMENTS[76741] = Fluid3D([16780,16923,16870,17282],0); -ELEMENTS[76742] = Fluid3D([16780,16923,17282,17056],0); -ELEMENTS[76743] = Fluid3D([11718,11989,11004,11896],0); -ELEMENTS[76744] = Fluid3D([15476,14816,14946,14951],0); -ELEMENTS[76745] = Fluid3D([15950,15927,15877,15424],0); -ELEMENTS[76746] = Fluid3D([15950,15927,15424,14933],0); -ELEMENTS[76747] = Fluid3D([4506,4810,4743,4101],0); -ELEMENTS[76748] = Fluid3D([8166,7213,7475,8296],0); -ELEMENTS[76749] = Fluid3D([13471,13440,14348,14437],0); -ELEMENTS[76750] = Fluid3D([1616,1671,1746,1618],0); -ELEMENTS[76751] = Fluid3D([11451,10346,11014,11293],0); -ELEMENTS[76752] = Fluid3D([4389,4261,4230,3814],0); -ELEMENTS[76753] = Fluid3D([16202,15797,15625,15840],0); -ELEMENTS[76754] = Fluid3D([7156,6937,6446,6132],0); -ELEMENTS[76755] = Fluid3D([17313,17057,16717,16719],0); -ELEMENTS[76756] = Fluid3D([17057,16717,16719,16686],0); -ELEMENTS[76757] = Fluid3D([4507,4991,5144,4751],0); -ELEMENTS[76758] = Fluid3D([2319,2555,2250,2501],0); -ELEMENTS[76759] = Fluid3D([2319,2555,2501,2598],0); -ELEMENTS[76760] = Fluid3D([2250,2319,2501,2262],0); -ELEMENTS[76761] = Fluid3D([2319,2501,2262,2598],0); -ELEMENTS[76762] = Fluid3D([13558,14373,13374,12979],0); -ELEMENTS[76763] = Fluid3D([13374,13558,12979,12504],0); -ELEMENTS[76764] = Fluid3D([14178,13234,13883,13815],0); -ELEMENTS[76765] = Fluid3D([14178,13234,13815,12907],0); -ELEMENTS[76766] = Fluid3D([16298,16129,16494,16261],0); -ELEMENTS[76767] = Fluid3D([11665,10725,10975,11030],0); -ELEMENTS[76768] = Fluid3D([2688,2635,2998,3148],0); -ELEMENTS[76769] = Fluid3D([13140,13964,13484,14003],0); -ELEMENTS[76770] = Fluid3D([14696,14618,13295,14085],0); -ELEMENTS[76771] = Fluid3D([14696,14618,14085,15489],0); -ELEMENTS[76772] = Fluid3D([16693,16278,16446,16574],0); -ELEMENTS[76773] = Fluid3D([8322,8354,7612,7209],0); -ELEMENTS[76774] = Fluid3D([9148,9628,8875,10414],0); -ELEMENTS[76775] = Fluid3D([10874,10652,11424,9961],0); -ELEMENTS[76776] = Fluid3D([5360,5350,5452,6225],0); -ELEMENTS[76777] = Fluid3D([5589,5726,5002,5100],0); -ELEMENTS[76778] = Fluid3D([17701,17788,17933,17653],0); -ELEMENTS[76779] = Fluid3D([11114,11763,11515,10893],0); -ELEMENTS[76780] = Fluid3D([12430,12857,12748,12319],0); -ELEMENTS[76781] = Fluid3D([16239,16529,16304,15745],0); -ELEMENTS[76782] = Fluid3D([1960,1942,1816,2007],0); -ELEMENTS[76783] = Fluid3D([6294,5841,5773,5439],0); -ELEMENTS[76784] = Fluid3D([17178,17466,17176,17190],0); -ELEMENTS[76785] = Fluid3D([14438,13501,14464,13819],0); -ELEMENTS[76786] = Fluid3D([16608,17111,16498,16381],0); -ELEMENTS[76787] = Fluid3D([5068,5478,4746,5331],0); -ELEMENTS[76788] = Fluid3D([4726,4769,4859,5220],0); -ELEMENTS[76789] = Fluid3D([13003,13203,12475,12164],0); -ELEMENTS[76790] = Fluid3D([17418,17302,17274,16963],0); -ELEMENTS[76791] = Fluid3D([18027,17807,17605,17739],0); -ELEMENTS[76792] = Fluid3D([17605,18027,17739,18073],0); -ELEMENTS[76793] = Fluid3D([4593,5157,4762,4973],0); -ELEMENTS[76794] = Fluid3D([17706,17609,17825,18033],0); -ELEMENTS[76795] = Fluid3D([6660,6319,5855,6132],0); -ELEMENTS[76796] = Fluid3D([8843,9682,9857,9135],0); -ELEMENTS[76797] = Fluid3D([13579,13926,13992,13307],0); -ELEMENTS[76798] = Fluid3D([17286,17348,16782,16944],0); -ELEMENTS[76799] = Fluid3D([18488,18476,18309,18346],0); -ELEMENTS[76800] = Fluid3D([18309,18488,18346,18490],0); -ELEMENTS[76801] = Fluid3D([7182,7446,7918,7236],0); -ELEMENTS[76802] = Fluid3D([17291,17116,17148,16945],0); -ELEMENTS[76803] = Fluid3D([3879,3990,4449,4105],0); -ELEMENTS[76804] = Fluid3D([13558,12615,12979,12504],0); -ELEMENTS[76805] = Fluid3D([8058,7367,8374,8655],0); -ELEMENTS[76806] = Fluid3D([6248,7034,6997,6320],0); -ELEMENTS[76807] = Fluid3D([3313,3760,3546,3555],0); -ELEMENTS[76808] = Fluid3D([3313,3760,3555,3221],0); -ELEMENTS[76809] = Fluid3D([15886,16244,15345,15990],0); -ELEMENTS[76810] = Fluid3D([7883,8840,8776,8492],0); -ELEMENTS[76811] = Fluid3D([13441,13406,13316,14464],0); -ELEMENTS[76812] = Fluid3D([4690,4851,5369,5443],0); -ELEMENTS[76813] = Fluid3D([17767,17660,17983,18120],0); -ELEMENTS[76814] = Fluid3D([15723,16223,16129,15287],0); -ELEMENTS[76815] = Fluid3D([2812,2548,2710,2650],0); -ELEMENTS[76816] = Fluid3D([12110,12816,11699,12804],0); -ELEMENTS[76817] = Fluid3D([10091,10020,9392,8614],0); -ELEMENTS[76818] = Fluid3D([16979,16708,16327,16798],0); -ELEMENTS[76819] = Fluid3D([9113,8884,7940,8344],0); -ELEMENTS[76820] = Fluid3D([9757,9056,9411,8675],0); -ELEMENTS[76821] = Fluid3D([7042,6645,6072,6910],0); -ELEMENTS[76822] = Fluid3D([12674,12824,12330,13518],0); -ELEMENTS[76823] = Fluid3D([4306,3848,3656,3886],0); -ELEMENTS[76824] = Fluid3D([16149,16446,15668,16278],0); -ELEMENTS[76825] = Fluid3D([7634,7937,8323,8161],0); -ELEMENTS[76826] = Fluid3D([13332,13754,14513,13809],0); -ELEMENTS[76827] = Fluid3D([8945,8291,8283,7629],0); -ELEMENTS[76828] = Fluid3D([1808,1966,1829,1849],0); -ELEMENTS[76829] = Fluid3D([2204,2503,2463,2431],0); -ELEMENTS[76830] = Fluid3D([15144,15526,15138,15563],0); -ELEMENTS[76831] = Fluid3D([12679,12162,13441,13458],0); -ELEMENTS[76832] = Fluid3D([17720,17554,17333,17317],0); -ELEMENTS[76833] = Fluid3D([8424,7605,8500,8009],0); -ELEMENTS[76834] = Fluid3D([11038,10580,11232,10368],0); -ELEMENTS[76835] = Fluid3D([15824,15054,15670,15774],0); -ELEMENTS[76836] = Fluid3D([14312,13877,14378,14874],0); -ELEMENTS[76837] = Fluid3D([3470,3726,3938,3621],0); -ELEMENTS[76838] = Fluid3D([3066,3209,3214,2888],0); -ELEMENTS[76839] = Fluid3D([8669,9093,8852,9633],0); -ELEMENTS[76840] = Fluid3D([8852,8669,9633,9361],0); -ELEMENTS[76841] = Fluid3D([17082,17297,17434,17289],0); -ELEMENTS[76842] = Fluid3D([13736,13739,12906,12703],0); -ELEMENTS[76843] = Fluid3D([3625,4237,3680,3955],0); -ELEMENTS[76844] = Fluid3D([3625,4237,3955,4094],0); -ELEMENTS[76845] = Fluid3D([18294,18063,18274,18096],0); -ELEMENTS[76846] = Fluid3D([15072,15470,15062,15668],0); -ELEMENTS[76847] = Fluid3D([3691,3837,4294,4281],0); -ELEMENTS[76848] = Fluid3D([3691,3837,4281,3827],0); -ELEMENTS[76849] = Fluid3D([3691,3837,3827,3682],0); -ELEMENTS[76850] = Fluid3D([5651,6315,5671,5967],0); -ELEMENTS[76851] = Fluid3D([13758,12555,12468,13085],0); -ELEMENTS[76852] = Fluid3D([10867,10093,9513,9481],0); -ELEMENTS[76853] = Fluid3D([10213,11542,11131,10004],0); -ELEMENTS[76854] = Fluid3D([15545,14908,14938,14802],0); -ELEMENTS[76855] = Fluid3D([14908,14938,14802,13845],0); -ELEMENTS[76856] = Fluid3D([4562,5079,4829,5335],0); -ELEMENTS[76857] = Fluid3D([14514,14461,15079,14674],0); -ELEMENTS[76858] = Fluid3D([16477,16124,15765,16553],0); -ELEMENTS[76859] = Fluid3D([5200,5393,5283,5781],0); -ELEMENTS[76860] = Fluid3D([9063,8580,9348,7934],0); -ELEMENTS[76861] = Fluid3D([8271,7749,9043,8044],0); -ELEMENTS[76862] = Fluid3D([15797,16202,16365,15840],0); -ELEMENTS[76863] = Fluid3D([9467,9319,10401,9850],0); -ELEMENTS[76864] = Fluid3D([5932,5847,5454,6376],0); -ELEMENTS[76865] = Fluid3D([9858,10604,9313,10099],0); -ELEMENTS[76866] = Fluid3D([15435,14907,15769,15602],0); -ELEMENTS[76867] = Fluid3D([13566,13177,14351,13754],0); -ELEMENTS[76868] = Fluid3D([17841,18143,17876,18097],0); -ELEMENTS[76869] = Fluid3D([3229,3619,3640,3817],0); -ELEMENTS[76870] = Fluid3D([6432,6416,7223,7312],0); -ELEMENTS[76871] = Fluid3D([6432,6416,7312,6741],0); -ELEMENTS[76872] = Fluid3D([16369,16340,16513,16977],0); -ELEMENTS[76873] = Fluid3D([14212,14765,14145,14612],0); -ELEMENTS[76874] = Fluid3D([11004,11896,10727,11676],0); -ELEMENTS[76875] = Fluid3D([9818,10860,10358,9919],0); -ELEMENTS[76876] = Fluid3D([16753,16580,15999,16669],0); -ELEMENTS[76877] = Fluid3D([15460,15190,14840,14427],0); -ELEMENTS[76878] = Fluid3D([13307,13571,14116,13992],0); -ELEMENTS[76879] = Fluid3D([3388,3077,2997,3437],0); -ELEMENTS[76880] = Fluid3D([3077,2997,3437,3198],0); -ELEMENTS[76881] = Fluid3D([12417,12673,11832,11115],0); -ELEMENTS[76882] = Fluid3D([1906,2057,2179,1955],0); -ELEMENTS[76883] = Fluid3D([7402,7832,7344,8299],0); -ELEMENTS[76884] = Fluid3D([7344,7402,8299,8246],0); -ELEMENTS[76885] = Fluid3D([18408,18267,18393,18354],0); -ELEMENTS[76886] = Fluid3D([8433,7825,7663,8293],0); -ELEMENTS[76887] = Fluid3D([7275,6338,6682,6639],0); -ELEMENTS[76888] = Fluid3D([9271,8704,9437,9484],0); -ELEMENTS[76889] = Fluid3D([18408,18457,18270,18354],0); -ELEMENTS[76890] = Fluid3D([4399,3993,3713,4215],0); -ELEMENTS[76891] = Fluid3D([3149,2898,2714,2914],0); -ELEMENTS[76892] = Fluid3D([9176,9160,8243,9241],0); -ELEMENTS[76893] = Fluid3D([8587,7990,8268,9226],0); -ELEMENTS[76894] = Fluid3D([4280,4156,3837,4294],0); -ELEMENTS[76895] = Fluid3D([4957,5256,5885,5542],0); -ELEMENTS[76896] = Fluid3D([10188,11156,10922,11662],0); -ELEMENTS[76897] = Fluid3D([13265,12644,13196,11986],0); -ELEMENTS[76898] = Fluid3D([13805,13277,12871,13023],0); -ELEMENTS[76899] = Fluid3D([2518,2803,2948,2674],0); -ELEMENTS[76900] = Fluid3D([18548,18598,18412,18543],0); -ELEMENTS[76901] = Fluid3D([2695,3038,3135,2851],0); -ELEMENTS[76902] = Fluid3D([9404,10006,8636,8886],0); -ELEMENTS[76903] = Fluid3D([6034,6284,6181,5449],0); -ELEMENTS[76904] = Fluid3D([6198,6017,6729,6103],0); -ELEMENTS[76905] = Fluid3D([11421,11488,12144,12065],0); -ELEMENTS[76906] = Fluid3D([11421,11488,12065,11220],0); -ELEMENTS[76907] = Fluid3D([6091,5606,6536,6216],0); -ELEMENTS[76908] = Fluid3D([6536,6091,6216,7117],0); -ELEMENTS[76909] = Fluid3D([7895,7874,7140,7663],0); -ELEMENTS[76910] = Fluid3D([3482,3329,3528,3844],0); -ELEMENTS[76911] = Fluid3D([18453,18260,18380,18210],0); -ELEMENTS[76912] = Fluid3D([17739,17992,18027,17985],0); -ELEMENTS[76913] = Fluid3D([17593,17664,17441,17884],0); -ELEMENTS[76914] = Fluid3D([10207,10410,11359,10542],0); -ELEMENTS[76915] = Fluid3D([16358,16257,15790,15502],0); -ELEMENTS[76916] = Fluid3D([11175,10847,10069,11391],0); -ELEMENTS[76917] = Fluid3D([16515,16955,17197,16818],0); -ELEMENTS[76918] = Fluid3D([8630,8213,8403,7587],0); -ELEMENTS[76919] = Fluid3D([8630,8213,7587,7422],0); -ELEMENTS[76920] = Fluid3D([8029,8672,7622,8789],0); -ELEMENTS[76921] = Fluid3D([17487,17398,17032,17542],0); -ELEMENTS[76922] = Fluid3D([14780,14301,13907,13702],0); -ELEMENTS[76923] = Fluid3D([16611,17167,16874,16444],0); -ELEMENTS[76924] = Fluid3D([17495,17254,16957,16976],0); -ELEMENTS[76925] = Fluid3D([12161,12448,13412,13172],0); -ELEMENTS[76926] = Fluid3D([9481,9513,8850,10093],0); -ELEMENTS[76927] = Fluid3D([3649,3658,3459,3090],0); -ELEMENTS[76928] = Fluid3D([11797,12317,11812,12299],0); -ELEMENTS[76929] = Fluid3D([11797,12317,12299,13299],0); -ELEMENTS[76930] = Fluid3D([8669,8852,8049,8440],0); -ELEMENTS[76931] = Fluid3D([12617,13409,13931,13469],0); -ELEMENTS[76932] = Fluid3D([11492,11511,12456,11845],0); -ELEMENTS[76933] = Fluid3D([5460,5751,5786,6164],0); -ELEMENTS[76934] = Fluid3D([4758,4584,4166,4170],0); -ELEMENTS[76935] = Fluid3D([13038,13449,14155,14128],0); -ELEMENTS[76936] = Fluid3D([7319,6341,6951,6526],0); -ELEMENTS[76937] = Fluid3D([16441,16007,15971,15585],0); -ELEMENTS[76938] = Fluid3D([6020,5764,6879,6556],0); -ELEMENTS[76939] = Fluid3D([14464,14443,13441,13406],0); -ELEMENTS[76940] = Fluid3D([14403,14003,13153,13484],0); -ELEMENTS[76941] = Fluid3D([3040,2944,3446,3267],0); -ELEMENTS[76942] = Fluid3D([7016,6449,7124,6321],0); -ELEMENTS[76943] = Fluid3D([14953,14391,14642,15396],0); -ELEMENTS[76944] = Fluid3D([16097,15916,15284,15939],0); -ELEMENTS[76945] = Fluid3D([10131,10207,11103,9613],0); -ELEMENTS[76946] = Fluid3D([14772,14538,15298,15278],0); -ELEMENTS[76947] = Fluid3D([4061,3760,3546,3596],0); -ELEMENTS[76948] = Fluid3D([4061,3760,3596,4217],0); -ELEMENTS[76949] = Fluid3D([8820,9685,9265,10249],0); -ELEMENTS[76950] = Fluid3D([16652,16607,15843,15893],0); -ELEMENTS[76951] = Fluid3D([2794,2946,3223,3181],0); -ELEMENTS[76952] = Fluid3D([17148,17291,16945,17373],0); -ELEMENTS[76953] = Fluid3D([5726,5002,5100,5743],0); -ELEMENTS[76954] = Fluid3D([3927,4264,4743,4215],0); -ELEMENTS[76955] = Fluid3D([16437,16007,15815,15517],0); -ELEMENTS[76956] = Fluid3D([3812,3984,4126,3530],0); -ELEMENTS[76957] = Fluid3D([3812,3984,3530,3329],0); -ELEMENTS[76958] = Fluid3D([4928,5760,5598,5084],0); -ELEMENTS[76959] = Fluid3D([5535,5883,6397,6156],0); -ELEMENTS[76960] = Fluid3D([15280,14813,14304,14329],0); -ELEMENTS[76961] = Fluid3D([11258,10494,10851,9832],0); -ELEMENTS[76962] = Fluid3D([10310,10867,9513,10027],0); -ELEMENTS[76963] = Fluid3D([16763,17142,17167,16444],0); -ELEMENTS[76964] = Fluid3D([11222,10922,10225,11156],0); -ELEMENTS[76965] = Fluid3D([12762,12963,13979,13524],0); -ELEMENTS[76966] = Fluid3D([8755,8866,9375,10344],0); -ELEMENTS[76967] = Fluid3D([14849,15097,14337,14555],0); -ELEMENTS[76968] = Fluid3D([3215,3043,3415,2854],0); -ELEMENTS[76969] = Fluid3D([12933,12910,12622,11551],0); -ELEMENTS[76970] = Fluid3D([8822,7866,7967,8233],0); -ELEMENTS[76971] = Fluid3D([14863,15683,15313,14960],0); -ELEMENTS[76972] = Fluid3D([6200,6112,5265,5315],0); -ELEMENTS[76973] = Fluid3D([15677,16260,16429,15831],0); -ELEMENTS[76974] = Fluid3D([11981,10954,11797,11671],0); -ELEMENTS[76975] = Fluid3D([2406,2582,2301,2381],0); -ELEMENTS[76976] = Fluid3D([5581,6203,6319,5545],0); -ELEMENTS[76977] = Fluid3D([15288,14838,14267,14243],0); -ELEMENTS[76978] = Fluid3D([14838,14267,14243,13615],0); -ELEMENTS[76979] = Fluid3D([11443,12231,11391,12203],0); -ELEMENTS[76980] = Fluid3D([14403,14154,13484,13153],0); -ELEMENTS[76981] = Fluid3D([14782,14279,13866,15068],0); -ELEMENTS[76982] = Fluid3D([15551,15057,15114,14309],0); -ELEMENTS[76983] = Fluid3D([7829,7926,8006,8702],0); -ELEMENTS[76984] = Fluid3D([13755,13733,12976,13746],0); -ELEMENTS[76985] = Fluid3D([17121,17440,16798,17145],0); -ELEMENTS[76986] = Fluid3D([11291,11152,10925,12143],0); -ELEMENTS[76987] = Fluid3D([11605,12366,11292,11407],0); -ELEMENTS[76988] = Fluid3D([15473,15996,15407,15247],0); -ELEMENTS[76989] = Fluid3D([11537,11163,10185,9898],0); -ELEMENTS[76990] = Fluid3D([11163,10185,9898,10503],0); -ELEMENTS[76991] = Fluid3D([9898,11163,10503,10470],0); -ELEMENTS[76992] = Fluid3D([9898,11163,10470,11537],0); -ELEMENTS[76993] = Fluid3D([9485,8749,8913,8157],0); -ELEMENTS[76994] = Fluid3D([2680,2568,2385,2263],0); -ELEMENTS[76995] = Fluid3D([14454,13997,14421,14866],0); -ELEMENTS[76996] = Fluid3D([14454,13997,14866,14916],0); -ELEMENTS[76997] = Fluid3D([15851,15676,16470,16469],0); -ELEMENTS[76998] = Fluid3D([16974,17266,16913,16500],0); -ELEMENTS[76999] = Fluid3D([13001,13277,14105,13964],0); -ELEMENTS[77000] = Fluid3D([13001,13277,13964,13261],0); -ELEMENTS[77001] = Fluid3D([4364,4753,4153,4832],0); -ELEMENTS[77002] = Fluid3D([15971,15585,16405,16441],0); -ELEMENTS[77003] = Fluid3D([17083,17220,16551,16729],0); -ELEMENTS[77004] = Fluid3D([11137,10326,11133,10827],0); -ELEMENTS[77005] = Fluid3D([10851,9832,10825,11258],0); -ELEMENTS[77006] = Fluid3D([10248,9484,9271,9437],0); -ELEMENTS[77007] = Fluid3D([5054,5442,5627,5679],0); -ELEMENTS[77008] = Fluid3D([18292,18182,18404,18300],0); -ELEMENTS[77009] = Fluid3D([10404,10829,9187,9636],0); -ELEMENTS[77010] = Fluid3D([11276,12141,12056,11950],0); -ELEMENTS[77011] = Fluid3D([16973,17271,16805,16767],0); -ELEMENTS[77012] = Fluid3D([3984,3812,3844,3329],0); -ELEMENTS[77013] = Fluid3D([6073,6608,6708,7126],0); -ELEMENTS[77014] = Fluid3D([16145,15703,15604,15714],0); -ELEMENTS[77015] = Fluid3D([10946,10452,11033,9804],0); -ELEMENTS[77016] = Fluid3D([12234,11972,12065,11109],0); -ELEMENTS[77017] = Fluid3D([12234,11972,11109,11220],0); -ELEMENTS[77018] = Fluid3D([12234,11972,11220,11225],0); -ELEMENTS[77019] = Fluid3D([11109,12234,11220,12065],0); -ELEMENTS[77020] = Fluid3D([12234,11220,12065,11488],0); -ELEMENTS[77021] = Fluid3D([12234,11220,11488,12721],0); -ELEMENTS[77022] = Fluid3D([18373,18078,18158,18266],0); -ELEMENTS[77023] = Fluid3D([15311,14991,14662,15618],0); -ELEMENTS[77024] = Fluid3D([17942,17542,17729,17487],0); -ELEMENTS[77025] = Fluid3D([8669,8440,9361,8852],0); -ELEMENTS[77026] = Fluid3D([13845,13891,14468,14943],0); -ELEMENTS[77027] = Fluid3D([8506,9051,7914,7731],0); -ELEMENTS[77028] = Fluid3D([5400,5608,5671,5028],0); -ELEMENTS[77029] = Fluid3D([17821,17938,18078,17889],0); -ELEMENTS[77030] = Fluid3D([18693,18675,18695,18686],0); -ELEMENTS[77031] = Fluid3D([11164,11135,11978,10638],0); -ELEMENTS[77032] = Fluid3D([17752,17532,17587,17493],0); -ELEMENTS[77033] = Fluid3D([2198,2007,2056,1942],0); -ELEMENTS[77034] = Fluid3D([3893,4255,4701,4558],0); -ELEMENTS[77035] = Fluid3D([5392,5044,4542,5108],0); -ELEMENTS[77036] = Fluid3D([12809,12780,13637,13775],0); -ELEMENTS[77037] = Fluid3D([2989,3271,3140,3576],0); -ELEMENTS[77038] = Fluid3D([15878,16022,15974,16565],0); -ELEMENTS[77039] = Fluid3D([8710,8758,8623,9812],0); -ELEMENTS[77040] = Fluid3D([10454,12076,11460,11559],0); -ELEMENTS[77041] = Fluid3D([9788,9942,10705,9682],0); -ELEMENTS[77042] = Fluid3D([11931,11623,10959,11900],0); -ELEMENTS[77043] = Fluid3D([10959,11931,11900,11820],0); -ELEMENTS[77044] = Fluid3D([7604,8270,7893,7478],0); -ELEMENTS[77045] = Fluid3D([2078,2257,2174,2464],0); -ELEMENTS[77046] = Fluid3D([15408,14817,14517,14694],0); -ELEMENTS[77047] = Fluid3D([3656,3397,3848,4029],0); -ELEMENTS[77048] = Fluid3D([5608,6260,6110,5671],0); -ELEMENTS[77049] = Fluid3D([12389,11975,13224,12427],0); -ELEMENTS[77050] = Fluid3D([11315,10498,11331,11839],0); -ELEMENTS[77051] = Fluid3D([10182,10455,9017,9416],0); -ELEMENTS[77052] = Fluid3D([9966,9258,10018,9540],0); -ELEMENTS[77053] = Fluid3D([2047,1933,2025,2170],0); -ELEMENTS[77054] = Fluid3D([1543,1616,1618,1671],0); -ELEMENTS[77055] = Fluid3D([9896,11149,10089,10896],0); -ELEMENTS[77056] = Fluid3D([9677,9054,9853,10009],0); -ELEMENTS[77057] = Fluid3D([15843,15893,16311,16652],0); -ELEMENTS[77058] = Fluid3D([18484,18332,18441,18223],0); -ELEMENTS[77059] = Fluid3D([1543,1618,1546,1671],0); -ELEMENTS[77060] = Fluid3D([12310,12114,11739,10960],0); -ELEMENTS[77061] = Fluid3D([13791,13318,12627,12869],0); -ELEMENTS[77062] = Fluid3D([16380,16624,16814,16731],0); -ELEMENTS[77063] = Fluid3D([6068,5556,6406,5880],0); -ELEMENTS[77064] = Fluid3D([7236,6984,8246,7572],0); -ELEMENTS[77065] = Fluid3D([16443,16497,16821,16063],0); -ELEMENTS[77066] = Fluid3D([16497,16821,16063,16412],0); -ELEMENTS[77067] = Fluid3D([11853,12700,12278,12734],0); -ELEMENTS[77068] = Fluid3D([8817,8996,9854,8595],0); -ELEMENTS[77069] = Fluid3D([10708,11512,11110,10255],0); -ELEMENTS[77070] = Fluid3D([3847,3572,4120,3594],0); -ELEMENTS[77071] = Fluid3D([7127,6505,7669,6680],0); -ELEMENTS[77072] = Fluid3D([16106,15697,16371,16667],0); -ELEMENTS[77073] = Fluid3D([6140,5713,5479,5626],0); -ELEMENTS[77074] = Fluid3D([9969,9287,9950,8979],0); -ELEMENTS[77075] = Fluid3D([14834,14936,15623,15206],0); -ELEMENTS[77076] = Fluid3D([12153,13079,13043,13503],0); -ELEMENTS[77077] = Fluid3D([16627,16430,17016,16688],0); -ELEMENTS[77078] = Fluid3D([16752,17108,16380,16818],0); -ELEMENTS[77079] = Fluid3D([7260,7604,7117,7852],0); -ELEMENTS[77080] = Fluid3D([6916,6179,6720,6887],0); -ELEMENTS[77081] = Fluid3D([15384,15888,15826,16249],0); -ELEMENTS[77082] = Fluid3D([15548,15862,15254,15728],0); -ELEMENTS[77083] = Fluid3D([9723,9385,10293,10855],0); -ELEMENTS[77084] = Fluid3D([5873,6311,6542,6632],0); -ELEMENTS[77085] = Fluid3D([10604,9313,10099,10193],0); -ELEMENTS[77086] = Fluid3D([18548,18562,18378,18421],0); -ELEMENTS[77087] = Fluid3D([11073,10232,10778,10131],0); -ELEMENTS[77088] = Fluid3D([14745,14947,14459,13952],0); -ELEMENTS[77089] = Fluid3D([6017,6729,6103,5819],0); -ELEMENTS[77090] = Fluid3D([8137,7537,8370,8651],0); -ELEMENTS[77091] = Fluid3D([10923,11258,10825,9832],0); -ELEMENTS[77092] = Fluid3D([13910,14100,14663,15040],0); -ELEMENTS[77093] = Fluid3D([17587,17752,17943,17875],0); -ELEMENTS[77094] = Fluid3D([16910,17025,16373,16366],0); -ELEMENTS[77095] = Fluid3D([7996,7609,8441,8247],0); -ELEMENTS[77096] = Fluid3D([7996,7609,8247,8556],0); -ELEMENTS[77097] = Fluid3D([7867,7776,8785,8055],0); -ELEMENTS[77098] = Fluid3D([13857,13504,13827,14444],0); -ELEMENTS[77099] = Fluid3D([18232,18329,18097,17876],0); -ELEMENTS[77100] = Fluid3D([3590,4143,3982,3528],0); -ELEMENTS[77101] = Fluid3D([18473,18577,18474,18600],0); -ELEMENTS[77102] = Fluid3D([12763,13179,12478,13205],0); -ELEMENTS[77103] = Fluid3D([5841,5650,5498,5043],0); -ELEMENTS[77104] = Fluid3D([15828,15188,15162,15852],0); -ELEMENTS[77105] = Fluid3D([14859,14847,15719,15390],0); -ELEMENTS[77106] = Fluid3D([15485,15109,14453,15246],0); -ELEMENTS[77107] = Fluid3D([11146,11537,11969,10786],0); -ELEMENTS[77108] = Fluid3D([3013,3273,2944,3446],0); -ELEMENTS[77109] = Fluid3D([2944,3013,3446,3267],0); -ELEMENTS[77110] = Fluid3D([17367,17109,17023,16992],0); -ELEMENTS[77111] = Fluid3D([14710,14760,15629,15348],0); -ELEMENTS[77112] = Fluid3D([4838,4641,4983,4449],0); -ELEMENTS[77113] = Fluid3D([13161,12751,12612,12062],0); -ELEMENTS[77114] = Fluid3D([5489,5038,4905,4899],0); -ELEMENTS[77115] = Fluid3D([18354,18393,18305,18100],0); -ELEMENTS[77116] = Fluid3D([17185,17391,17243,17008],0); -ELEMENTS[77117] = Fluid3D([13055,13711,14064,14450],0); -ELEMENTS[77118] = Fluid3D([12625,13043,13504,13827],0); -ELEMENTS[77119] = Fluid3D([12408,12910,12116,13434],0); -ELEMENTS[77120] = Fluid3D([11652,11891,12531,11433],0); -ELEMENTS[77121] = Fluid3D([14478,14706,13872,14375],0); -ELEMENTS[77122] = Fluid3D([14478,14706,14375,15268],0); -ELEMENTS[77123] = Fluid3D([14157,14722,14403,14837],0); -ELEMENTS[77124] = Fluid3D([14403,14157,14837,13716],0); -ELEMENTS[77125] = Fluid3D([11605,12418,11775,11900],0); -ELEMENTS[77126] = Fluid3D([4650,4723,5223,5524],0); -ELEMENTS[77127] = Fluid3D([15503,16155,16030,16213],0); -ELEMENTS[77128] = Fluid3D([8105,7051,7624,7936],0); -ELEMENTS[77129] = Fluid3D([5851,6496,6812,6277],0); -ELEMENTS[77130] = Fluid3D([17889,17638,17972,18078],0); -ELEMENTS[77131] = Fluid3D([17972,17889,18078,18266],0); -ELEMENTS[77132] = Fluid3D([17889,17638,18078,17755],0); -ELEMENTS[77133] = Fluid3D([3962,3623,3861,4205],0); -ELEMENTS[77134] = Fluid3D([3623,3861,4205,3548],0); -ELEMENTS[77135] = Fluid3D([3861,4205,3548,4089],0); -ELEMENTS[77136] = Fluid3D([17881,17915,17484,17908],0); -ELEMENTS[77137] = Fluid3D([12432,12831,12015,12444],0); -ELEMENTS[77138] = Fluid3D([12831,12015,12444,13525],0); -ELEMENTS[77139] = Fluid3D([12174,12876,13337,13157],0); -ELEMENTS[77140] = Fluid3D([6262,6690,6645,5757],0); -ELEMENTS[77141] = Fluid3D([15867,15765,15419,16265],0); -ELEMENTS[77142] = Fluid3D([18220,18099,17843,18025],0); -ELEMENTS[77143] = Fluid3D([17952,18025,18177,18057],0); -ELEMENTS[77144] = Fluid3D([17843,18025,17952,18057],0); -ELEMENTS[77145] = Fluid3D([18220,18099,18025,18177],0); -ELEMENTS[77146] = Fluid3D([18025,18220,18177,18057],0); -ELEMENTS[77147] = Fluid3D([8627,7869,8847,8543],0); -ELEMENTS[77148] = Fluid3D([9173,8987,10224,9521],0); -ELEMENTS[77149] = Fluid3D([9173,8987,9521,8335],0); -ELEMENTS[77150] = Fluid3D([7143,7351,6462,7539],0); -ELEMENTS[77151] = Fluid3D([18502,18565,18589,18624],0); -ELEMENTS[77152] = Fluid3D([11819,10850,10447,11280],0); -ELEMENTS[77153] = Fluid3D([5907,5843,6572,6247],0); -ELEMENTS[77154] = Fluid3D([3667,4109,3851,3681],0); -ELEMENTS[77155] = Fluid3D([14863,14938,13995,13842],0); -ELEMENTS[77156] = Fluid3D([3421,3187,3829,3688],0); -ELEMENTS[77157] = Fluid3D([11294,10795,12094,12120],0); -ELEMENTS[77158] = Fluid3D([14815,15566,15294,14594],0); -ELEMENTS[77159] = Fluid3D([8882,9597,8379,9208],0); -ELEMENTS[77160] = Fluid3D([3770,4350,4125,3945],0); -ELEMENTS[77161] = Fluid3D([8217,8820,7629,8945],0); -ELEMENTS[77162] = Fluid3D([8790,9381,9678,8634],0); -ELEMENTS[77163] = Fluid3D([8427,8819,9319,9850],0); -ELEMENTS[77164] = Fluid3D([4089,3609,3845,3840],0); -ELEMENTS[77165] = Fluid3D([11676,11050,11556,10945],0); -ELEMENTS[77166] = Fluid3D([16190,15690,15838,16339],0); -ELEMENTS[77167] = Fluid3D([9216,9589,9398,10316],0); -ELEMENTS[77168] = Fluid3D([9377,10362,10494,9140],0); -ELEMENTS[77169] = Fluid3D([11277,10056,10488,9936],0); -ELEMENTS[77170] = Fluid3D([12279,11188,12186,11732],0); -ELEMENTS[77171] = Fluid3D([7291,6372,6299,6957],0); -ELEMENTS[77172] = Fluid3D([13084,13817,13958,13587],0); -ELEMENTS[77173] = Fluid3D([14262,14164,13863,13123],0); -ELEMENTS[77174] = Fluid3D([5806,6339,6618,6887],0); -ELEMENTS[77175] = Fluid3D([2639,2648,3053,2775],0); -ELEMENTS[77176] = Fluid3D([12636,12929,13017,13913],0); -ELEMENTS[77177] = Fluid3D([9727,9284,10040,10512],0); -ELEMENTS[77178] = Fluid3D([11681,11591,12801,12538],0); -ELEMENTS[77179] = Fluid3D([7470,6823,7594,7146],0); -ELEMENTS[77180] = Fluid3D([6823,7594,7146,6118],0); -ELEMENTS[77181] = Fluid3D([15465,15416,14743,15405],0); -ELEMENTS[77182] = Fluid3D([7484,7594,6967,6232],0); -ELEMENTS[77183] = Fluid3D([5091,5463,4666,5100],0); -ELEMENTS[77184] = Fluid3D([11050,11676,10435,10945],0); -ELEMENTS[77185] = Fluid3D([11087,10344,11373,10430],0); -ELEMENTS[77186] = Fluid3D([3492,3990,3484,4009],0); -ELEMENTS[77187] = Fluid3D([7663,7140,7825,7874],0); -ELEMENTS[77188] = Fluid3D([17664,17593,17979,17884],0); -ELEMENTS[77189] = Fluid3D([8282,7489,7904,7458],0); -ELEMENTS[77190] = Fluid3D([7936,8105,9230,8337],0); -ELEMENTS[77191] = Fluid3D([7936,8105,8337,7624],0); -ELEMENTS[77192] = Fluid3D([11076,11043,11984,12336],0); -ELEMENTS[77193] = Fluid3D([16448,15896,15633,16259],0); -ELEMENTS[77194] = Fluid3D([9011,9093,9336,10313],0); -ELEMENTS[77195] = Fluid3D([11102,12106,11513,11436],0); -ELEMENTS[77196] = Fluid3D([4523,4875,4979,5238],0); -ELEMENTS[77197] = Fluid3D([14551,14813,14329,13859],0); -ELEMENTS[77198] = Fluid3D([5996,6248,6251,5602],0); -ELEMENTS[77199] = Fluid3D([4419,4477,4804,4060],0); -ELEMENTS[77200] = Fluid3D([6072,6554,7142,7042],0); -ELEMENTS[77201] = Fluid3D([2542,2775,2914,3053],0); -ELEMENTS[77202] = Fluid3D([17111,17302,16963,16608],0); -ELEMENTS[77203] = Fluid3D([16963,17111,16608,16381],0); -ELEMENTS[77204] = Fluid3D([10596,11118,11447,11591],0); -ELEMENTS[77205] = Fluid3D([9151,9850,8819,8427],0); -ELEMENTS[77206] = Fluid3D([5379,4754,4873,5142],0); -ELEMENTS[77207] = Fluid3D([11054,11467,10562,9949],0); -ELEMENTS[77208] = Fluid3D([16374,16593,16676,17010],0); -ELEMENTS[77209] = Fluid3D([18070,18168,17813,18096],0); -ELEMENTS[77210] = Fluid3D([18168,17813,18096,18063],0); -ELEMENTS[77211] = Fluid3D([14561,15136,15015,15617],0); -ELEMENTS[77212] = Fluid3D([11114,11763,10893,10345],0); -ELEMENTS[77213] = Fluid3D([10672,11077,11433,11440],0); -ELEMENTS[77214] = Fluid3D([9556,10558,10007,10149],0); -ELEMENTS[77215] = Fluid3D([16117,16325,16800,16516],0); -ELEMENTS[77216] = Fluid3D([13637,12780,12801,13775],0); -ELEMENTS[77217] = Fluid3D([14892,15002,15453,15848],0); -ELEMENTS[77218] = Fluid3D([14666,15049,15370,15488],0); -ELEMENTS[77219] = Fluid3D([3168,3135,2819,3158],0); -ELEMENTS[77220] = Fluid3D([9970,9812,8860,8710],0); -ELEMENTS[77221] = Fluid3D([11325,10430,10988,11294],0); -ELEMENTS[77222] = Fluid3D([11325,10430,11294,11087],0); -ELEMENTS[77223] = Fluid3D([13103,13333,13652,14077],0); -ELEMENTS[77224] = Fluid3D([17025,16912,16373,16366],0); -ELEMENTS[77225] = Fluid3D([5135,5473,5065,4804],0); -ELEMENTS[77226] = Fluid3D([14763,14307,14370,14732],0); -ELEMENTS[77227] = Fluid3D([7015,6908,6875,7493],0); -ELEMENTS[77228] = Fluid3D([7015,6908,7493,7360],0); -ELEMENTS[77229] = Fluid3D([8096,8116,6985,6923],0); -ELEMENTS[77230] = Fluid3D([16255,16301,16823,16993],0); -ELEMENTS[77231] = Fluid3D([10869,11927,10727,11781],0); -ELEMENTS[77232] = Fluid3D([12555,12704,13085,13758],0); -ELEMENTS[77233] = Fluid3D([11729,11921,12190,13073],0); -ELEMENTS[77234] = Fluid3D([5222,4704,4487,4886],0); -ELEMENTS[77235] = Fluid3D([5612,5853,6034,5409],0); -ELEMENTS[77236] = Fluid3D([8488,7662,7614,7647],0); -ELEMENTS[77237] = Fluid3D([8525,8203,8921,8145],0); -ELEMENTS[77238] = Fluid3D([17195,17208,16709,16888],0); -ELEMENTS[77239] = Fluid3D([16443,16497,16063,15826],0); -ELEMENTS[77240] = Fluid3D([16497,16063,15826,16204],0); -ELEMENTS[77241] = Fluid3D([16497,16063,16204,16412],0); -ELEMENTS[77242] = Fluid3D([16063,16204,16412,15562],0); -ELEMENTS[77243] = Fluid3D([6346,6233,5421,5816],0); -ELEMENTS[77244] = Fluid3D([16356,16881,16303,16700],0); -ELEMENTS[77245] = Fluid3D([11286,11931,12702,12690],0); -ELEMENTS[77246] = Fluid3D([16814,16752,16380,16150],0); -ELEMENTS[77247] = Fluid3D([4700,4768,4128,4655],0); -ELEMENTS[77248] = Fluid3D([11375,11995,12684,11675],0); -ELEMENTS[77249] = Fluid3D([5779,5390,5352,5316],0); -ELEMENTS[77250] = Fluid3D([3908,3813,4300,3692],0); -ELEMENTS[77251] = Fluid3D([13735,12974,13984,13710],0); -ELEMENTS[77252] = Fluid3D([12085,11897,12496,13161],0); -ELEMENTS[77253] = Fluid3D([4772,4802,4489,4064],0); -ELEMENTS[77254] = Fluid3D([15633,15381,15346,16084],0); -ELEMENTS[77255] = Fluid3D([15633,15381,16084,16259],0); -ELEMENTS[77256] = Fluid3D([15684,15933,15801,16362],0); -ELEMENTS[77257] = Fluid3D([8721,8247,9655,9000],0); -ELEMENTS[77258] = Fluid3D([4325,4248,3714,3980],0); -ELEMENTS[77259] = Fluid3D([6370,7156,6132,6937],0); -ELEMENTS[77260] = Fluid3D([14513,15283,14858,14027],0); -ELEMENTS[77261] = Fluid3D([13149,13334,12268,11952],0); -ELEMENTS[77262] = Fluid3D([6256,6059,6639,5428],0); -ELEMENTS[77263] = Fluid3D([18562,18589,18502,18374],0); -ELEMENTS[77264] = Fluid3D([8453,9411,9237,9056],0); -ELEMENTS[77265] = Fluid3D([16605,16816,16523,16251],0); -ELEMENTS[77266] = Fluid3D([9357,9353,8282,9516],0); -ELEMENTS[77267] = Fluid3D([7992,7005,7618,8217],0); -ELEMENTS[77268] = Fluid3D([2512,2340,2581,2742],0); -ELEMENTS[77269] = Fluid3D([8372,8585,9064,8439],0); -ELEMENTS[77270] = Fluid3D([7856,8646,8898,8614],0); -ELEMENTS[77271] = Fluid3D([18511,18397,18465,18438],0); -ELEMENTS[77272] = Fluid3D([18511,18397,18438,18220],0); -ELEMENTS[77273] = Fluid3D([6376,5454,6185,5847],0); -ELEMENTS[77274] = Fluid3D([8350,8816,8884,8612],0); -ELEMENTS[77275] = Fluid3D([14834,15547,15052,15330],0); -ELEMENTS[77276] = Fluid3D([15664,16213,15749,15503],0); -ELEMENTS[77277] = Fluid3D([3526,3572,3594,4120],0); -ELEMENTS[77278] = Fluid3D([10894,11704,10506,11019],0); -ELEMENTS[77279] = Fluid3D([17791,17972,17623,17638],0); -ELEMENTS[77280] = Fluid3D([10779,10561,11799,11203],0); -ELEMENTS[77281] = Fluid3D([7628,7320,7726,6949],0); -ELEMENTS[77282] = Fluid3D([18254,18196,18245,18023],0); -ELEMENTS[77283] = Fluid3D([15944,15918,16570,16368],0); -ELEMENTS[77284] = Fluid3D([14521,15262,14374,14913],0); -ELEMENTS[77285] = Fluid3D([16459,16095,15538,16016],0); -ELEMENTS[77286] = Fluid3D([4990,4459,4983,4641],0); -ELEMENTS[77287] = Fluid3D([10429,10372,11216,11800],0); -ELEMENTS[77288] = Fluid3D([2288,2124,2109,2263],0); -ELEMENTS[77289] = Fluid3D([12638,12760,12902,11581],0); -ELEMENTS[77290] = Fluid3D([8858,7925,8217,8639],0); -ELEMENTS[77291] = Fluid3D([5682,5726,5002,5108],0); -ELEMENTS[77292] = Fluid3D([8962,9181,10309,9884],0); -ELEMENTS[77293] = Fluid3D([6566,6523,6835,5981],0); -ELEMENTS[77294] = Fluid3D([6258,5932,5562,6376],0); -ELEMENTS[77295] = Fluid3D([12282,12762,11866,11682],0); -ELEMENTS[77296] = Fluid3D([18322,18455,18461,18201],0); -ELEMENTS[77297] = Fluid3D([15557,15818,15639,15046],0); -ELEMENTS[77298] = Fluid3D([15818,15639,15046,15732],0); -ELEMENTS[77299] = Fluid3D([9152,8970,8784,7791],0); -ELEMENTS[77300] = Fluid3D([18267,18112,18393,18354],0); -ELEMENTS[77301] = Fluid3D([18112,18393,18354,18100],0); -ELEMENTS[77302] = Fluid3D([14164,14849,13863,14337],0); -ELEMENTS[77303] = Fluid3D([14154,13926,13153,14237],0); -ELEMENTS[77304] = Fluid3D([14154,13926,14237,15133],0); -ELEMENTS[77305] = Fluid3D([8323,8882,8161,8429],0); -ELEMENTS[77306] = Fluid3D([16076,15769,15602,15435],0); -ELEMENTS[77307] = Fluid3D([13609,13957,13555,14433],0); -ELEMENTS[77308] = Fluid3D([16274,16624,16731,16868],0); -ELEMENTS[77309] = Fluid3D([7647,7614,6527,6797],0); -ELEMENTS[77310] = Fluid3D([6103,5627,6204,6198],0); -ELEMENTS[77311] = Fluid3D([4101,3786,4141,4506],0); -ELEMENTS[77312] = Fluid3D([7662,8488,7917,7647],0); -ELEMENTS[77313] = Fluid3D([16814,16731,16150,16380],0); -ELEMENTS[77314] = Fluid3D([10343,9804,10946,11033],0); -ELEMENTS[77315] = Fluid3D([6667,6386,7461,7757],0); -ELEMENTS[77316] = Fluid3D([5824,5995,5847,5303],0); -ELEMENTS[77317] = Fluid3D([2207,2028,2263,2310],0); -ELEMENTS[77318] = Fluid3D([4803,5120,5429,4907],0); -ELEMENTS[77319] = Fluid3D([7041,7316,8096,6985],0); -ELEMENTS[77320] = Fluid3D([2859,2569,2750,2963],0); -ELEMENTS[77321] = Fluid3D([16692,16812,17347,17171],0); -ELEMENTS[77322] = Fluid3D([4781,4442,4754,4181],0); -ELEMENTS[77323] = Fluid3D([18628,18593,18535,18638],0); -ELEMENTS[77324] = Fluid3D([7199,6885,7981,7259],0); -ELEMENTS[77325] = Fluid3D([13738,12831,12432,13310],0); -ELEMENTS[77326] = Fluid3D([17700,17352,17634,17383],0); -ELEMENTS[77327] = Fluid3D([6093,6294,6073,5439],0); -ELEMENTS[77328] = Fluid3D([11551,11020,11159,11590],0); -ELEMENTS[77329] = Fluid3D([4744,4427,4672,4516],0); -ELEMENTS[77330] = Fluid3D([14907,15435,15573,15602],0); -ELEMENTS[77331] = Fluid3D([12226,11565,12538,11336],0); -ELEMENTS[77332] = Fluid3D([10924,10848,10205,9378],0); -ELEMENTS[77333] = Fluid3D([15309,14789,14767,15071],0); -ELEMENTS[77334] = Fluid3D([8635,8810,9544,9785],0); -ELEMENTS[77335] = Fluid3D([17951,17905,17775,18123],0); -ELEMENTS[77336] = Fluid3D([8337,8292,8105,9230],0); -ELEMENTS[77337] = Fluid3D([15457,15543,16123,16263],0); -ELEMENTS[77338] = Fluid3D([15774,15990,16314,15886],0); -ELEMENTS[77339] = Fluid3D([3720,3480,3437,3168],0); -ELEMENTS[77340] = Fluid3D([2986,3215,3415,2854],0); -ELEMENTS[77341] = Fluid3D([1795,1840,1932,1722],0); -ELEMENTS[77342] = Fluid3D([9633,9834,10313,9093],0); -ELEMENTS[77343] = Fluid3D([12551,12849,11895,13015],0); -ELEMENTS[77344] = Fluid3D([3873,3783,4112,3659],0); -ELEMENTS[77345] = Fluid3D([9772,8548,9814,8995],0); -ELEMENTS[77346] = Fluid3D([11565,12174,12538,11336],0); -ELEMENTS[77347] = Fluid3D([16628,16508,16953,16440],0); -ELEMENTS[77348] = Fluid3D([16508,16953,16440,17190],0); -ELEMENTS[77349] = Fluid3D([3036,2743,2828,2792],0); -ELEMENTS[77350] = Fluid3D([10776,9788,10215,9709],0); -ELEMENTS[77351] = Fluid3D([7765,7422,8630,7587],0); -ELEMENTS[77352] = Fluid3D([14156,14077,13103,13652],0); -ELEMENTS[77353] = Fluid3D([16514,16437,16619,17051],0); -ELEMENTS[77354] = Fluid3D([15122,15468,16062,15659],0); -ELEMENTS[77355] = Fluid3D([13090,13467,13980,14385],0); -ELEMENTS[77356] = Fluid3D([2413,2644,2638,2260],0); -ELEMENTS[77357] = Fluid3D([8576,7823,7781,8074],0); -ELEMENTS[77358] = Fluid3D([13668,13868,13955,13190],0); -ELEMENTS[77359] = Fluid3D([13668,13868,13190,12721],0); -ELEMENTS[77360] = Fluid3D([17040,16798,17440,17145],0); -ELEMENTS[77361] = Fluid3D([8505,8323,7818,7284],0); -ELEMENTS[77362] = Fluid3D([17084,17519,17525,17442],0); -ELEMENTS[77363] = Fluid3D([11786,11969,12164,11314],0); -ELEMENTS[77364] = Fluid3D([13915,13263,14033,14487],0); -ELEMENTS[77365] = Fluid3D([12929,13174,12058,13017],0); -ELEMENTS[77366] = Fluid3D([4784,5040,4912,4274],0); -ELEMENTS[77367] = Fluid3D([7309,7000,7403,8182],0); -ELEMENTS[77368] = Fluid3D([11403,10835,12142,11843],0); -ELEMENTS[77369] = Fluid3D([18099,18220,18288,18177],0); -ELEMENTS[77370] = Fluid3D([2835,2749,2451,2381],0); -ELEMENTS[77371] = Fluid3D([15747,16258,15654,15676],0); -ELEMENTS[77372] = Fluid3D([3540,3530,3434,3163],0); -ELEMENTS[77373] = Fluid3D([8596,8618,7502,7650],0); -ELEMENTS[77374] = Fluid3D([12165,12823,13486,13165],0); -ELEMENTS[77375] = Fluid3D([10870,9576,9971,10098],0); -ELEMENTS[77376] = Fluid3D([4583,4097,4753,4568],0); -ELEMENTS[77377] = Fluid3D([16301,16005,16823,16651],0); -ELEMENTS[77378] = Fluid3D([3986,3840,3609,4089],0); -ELEMENTS[77379] = Fluid3D([17521,17313,16987,17272],0); -ELEMENTS[77380] = Fluid3D([6251,5996,5602,5615],0); -ELEMENTS[77381] = Fluid3D([12958,12519,13244,13749],0); -ELEMENTS[77382] = Fluid3D([5521,5133,5173,5385],0); -ELEMENTS[77383] = Fluid3D([11945,12388,11935,11703],0); -ELEMENTS[77384] = Fluid3D([3094,3312,3362,3776],0); -ELEMENTS[77385] = Fluid3D([6893,6862,7572,7698],0); -ELEMENTS[77386] = Fluid3D([14938,13995,13842,14802],0); -ELEMENTS[77387] = Fluid3D([16084,16259,16448,15633],0); -ELEMENTS[77388] = Fluid3D([18496,18498,18391,18503],0); -ELEMENTS[77389] = Fluid3D([12203,12665,11391,12110],0); -ELEMENTS[77390] = Fluid3D([13459,13127,13866,14295],0); -ELEMENTS[77391] = Fluid3D([10350,10980,9598,9728],0); -ELEMENTS[77392] = Fluid3D([16319,16263,16968,16123],0); -ELEMENTS[77393] = Fluid3D([16319,16263,16123,15543],0); -ELEMENTS[77394] = Fluid3D([9678,9471,10459,9495],0); -ELEMENTS[77395] = Fluid3D([10900,10595,9847,10848],0); -ELEMENTS[77396] = Fluid3D([7226,7319,6951,6526],0); -ELEMENTS[77397] = Fluid3D([18032,17921,18043,17846],0); -ELEMENTS[77398] = Fluid3D([16957,17495,16976,17446],0); -ELEMENTS[77399] = Fluid3D([14194,13749,13760,12958],0); -ELEMENTS[77400] = Fluid3D([10091,10721,9786,11472],0); -ELEMENTS[77401] = Fluid3D([4949,4929,5562,5543],0); -ELEMENTS[77402] = Fluid3D([16917,16537,16290,16416],0); -ELEMENTS[77403] = Fluid3D([14071,13805,13277,13964],0); -ELEMENTS[77404] = Fluid3D([17327,16922,17526,17365],0); -ELEMENTS[77405] = Fluid3D([17525,17278,17077,16795],0); -ELEMENTS[77406] = Fluid3D([15862,15728,15470,15062],0); -ELEMENTS[77407] = Fluid3D([15862,15728,15062,15254],0); -ELEMENTS[77408] = Fluid3D([16555,16762,16799,16160],0); -ELEMENTS[77409] = Fluid3D([8379,7889,8648,7418],0); -ELEMENTS[77410] = Fluid3D([3848,3965,3464,3886],0); -ELEMENTS[77411] = Fluid3D([3402,3810,3618,3410],0); -ELEMENTS[77412] = Fluid3D([14833,14913,14021,14374],0); -ELEMENTS[77413] = Fluid3D([11448,10553,11095,10552],0); -ELEMENTS[77414] = Fluid3D([3430,3508,3878,3922],0); -ELEMENTS[77415] = Fluid3D([3787,4302,3911,4292],0); -ELEMENTS[77416] = Fluid3D([3911,3787,4292,3523],0); -ELEMENTS[77417] = Fluid3D([13441,13316,13501,14464],0); -ELEMENTS[77418] = Fluid3D([10181,9444,9936,8452],0); -ELEMENTS[77419] = Fluid3D([9327,9448,9715,8325],0); -ELEMENTS[77420] = Fluid3D([15995,16376,15725,15798],0); -ELEMENTS[77421] = Fluid3D([15257,15714,15604,15703],0); -ELEMENTS[77422] = Fluid3D([7698,7572,6868,6862],0); -ELEMENTS[77423] = Fluid3D([18212,18102,18351,18125],0); -ELEMENTS[77424] = Fluid3D([4190,4731,4469,4562],0); -ELEMENTS[77425] = Fluid3D([4731,4469,4562,5335],0); -ELEMENTS[77426] = Fluid3D([4190,4731,4562,4173],0); -ELEMENTS[77427] = Fluid3D([15403,15536,14548,15131],0); -ELEMENTS[77428] = Fluid3D([16322,15841,16108,16363],0); -ELEMENTS[77429] = Fluid3D([3370,3314,3061,3693],0); -ELEMENTS[77430] = Fluid3D([9448,8325,8742,9451],0); -ELEMENTS[77431] = Fluid3D([10797,11811,11466,12316],0); -ELEMENTS[77432] = Fluid3D([10741,11205,11050,12072],0); -ELEMENTS[77433] = Fluid3D([16889,16836,16192,16576],0); -ELEMENTS[77434] = Fluid3D([5316,5516,5857,5386],0); -ELEMENTS[77435] = Fluid3D([12156,12195,11240,11944],0); -ELEMENTS[77436] = Fluid3D([6689,6183,6516,5694],0); -ELEMENTS[77437] = Fluid3D([10249,9685,9837,8820],0); -ELEMENTS[77438] = Fluid3D([10959,9924,10612,9330],0); -ELEMENTS[77439] = Fluid3D([18574,18565,18555,18647],0); -ELEMENTS[77440] = Fluid3D([7269,7825,8583,8293],0); -ELEMENTS[77441] = Fluid3D([18633,18566,18575,18527],0); -ELEMENTS[77442] = Fluid3D([2788,2516,2590,2507],0); -ELEMENTS[77443] = Fluid3D([8440,8788,8852,8049],0); -ELEMENTS[77444] = Fluid3D([8788,8852,8049,8165],0); -ELEMENTS[77445] = Fluid3D([18381,18400,18133,18216],0); -ELEMENTS[77446] = Fluid3D([17349,17589,17335,17066],0); -ELEMENTS[77447] = Fluid3D([5985,6718,6689,5719],0); -ELEMENTS[77448] = Fluid3D([17841,17650,18088,18097],0); -ELEMENTS[77449] = Fluid3D([18276,18431,18287,18510],0); -ELEMENTS[77450] = Fluid3D([9920,10404,9090,9690],0); -ELEMENTS[77451] = Fluid3D([12792,13579,13053,13992],0); -ELEMENTS[77452] = Fluid3D([14202,13353,13125,13505],0); -ELEMENTS[77453] = Fluid3D([3737,4220,4150,3950],0); -ELEMENTS[77454] = Fluid3D([7316,6923,7728,8096],0); -ELEMENTS[77455] = Fluid3D([3646,3873,3223,3351],0); -ELEMENTS[77456] = Fluid3D([14121,14605,13866,13362],0); -ELEMENTS[77457] = Fluid3D([13706,13950,13913,13017],0); -ELEMENTS[77458] = Fluid3D([13913,13706,13017,12636],0); -ELEMENTS[77459] = Fluid3D([7340,7299,7711,6802],0); -ELEMENTS[77460] = Fluid3D([10263,9475,10239,11062],0); -ELEMENTS[77461] = Fluid3D([13809,13332,13715,14513],0); -ELEMENTS[77462] = Fluid3D([12367,11300,12212,12097],0); -ELEMENTS[77463] = Fluid3D([6601,5848,6965,6090],0); -ELEMENTS[77464] = Fluid3D([18151,18291,18193,18402],0); -ELEMENTS[77465] = Fluid3D([7757,7419,7461,6667],0); -ELEMENTS[77466] = Fluid3D([7837,7508,7374,8368],0); -ELEMENTS[77467] = Fluid3D([12891,11823,12704,13085],0); -ELEMENTS[77468] = Fluid3D([4071,3631,3673,3623],0); -ELEMENTS[77469] = Fluid3D([2477,2611,2727,2998],0); -ELEMENTS[77470] = Fluid3D([17364,17446,16873,17103],0); -ELEMENTS[77471] = Fluid3D([8027,8272,7123,7768],0); -ELEMENTS[77472] = Fluid3D([5352,5602,5486,6248],0); -ELEMENTS[77473] = Fluid3D([15714,15423,15972,16359],0); -ELEMENTS[77474] = Fluid3D([13628,13648,14073,14750],0); -ELEMENTS[77475] = Fluid3D([13228,13315,14421,13784],0); -ELEMENTS[77476] = Fluid3D([9296,9257,8623,8367],0); -ELEMENTS[77477] = Fluid3D([9296,9257,8367,9224],0); -ELEMENTS[77478] = Fluid3D([9296,9257,9224,10587],0); -ELEMENTS[77479] = Fluid3D([8367,9296,9224,8623],0); -ELEMENTS[77480] = Fluid3D([6892,7628,7501,6949],0); -ELEMENTS[77481] = Fluid3D([15347,15076,14696,15241],0); -ELEMENTS[77482] = Fluid3D([14696,15347,15241,15556],0); -ELEMENTS[77483] = Fluid3D([17505,17041,17066,17589],0); -ELEMENTS[77484] = Fluid3D([7368,7413,8396,7641],0); -ELEMENTS[77485] = Fluid3D([16131,15557,15639,15139],0); -ELEMENTS[77486] = Fluid3D([17775,17786,17951,18123],0); -ELEMENTS[77487] = Fluid3D([17969,18039,18300,18255],0); -ELEMENTS[77488] = Fluid3D([12683,12995,11861,12237],0); -ELEMENTS[77489] = Fluid3D([14843,14865,15820,15659],0); -ELEMENTS[77490] = Fluid3D([4343,4202,4466,4883],0); -ELEMENTS[77491] = Fluid3D([3118,3181,3223,3646],0); -ELEMENTS[77492] = Fluid3D([3118,3181,3646,3381],0); -ELEMENTS[77493] = Fluid3D([11790,11164,11978,12554],0); -ELEMENTS[77494] = Fluid3D([5426,5984,5676,5812],0); -ELEMENTS[77495] = Fluid3D([7249,7529,8347,7740],0); -ELEMENTS[77496] = Fluid3D([12947,12856,12691,11914],0); -ELEMENTS[77497] = Fluid3D([5650,5841,5439,5153],0); -ELEMENTS[77498] = Fluid3D([2969,3198,2664,3077],0); -ELEMENTS[77499] = Fluid3D([17030,16529,16877,16304],0); -ELEMENTS[77500] = Fluid3D([16303,15957,16700,16057],0); -ELEMENTS[77501] = Fluid3D([14323,14056,13789,13341],0); -ELEMENTS[77502] = Fluid3D([17312,17682,17226,17407],0); -ELEMENTS[77503] = Fluid3D([6572,7363,7396,7969],0); -ELEMENTS[77504] = Fluid3D([16581,16698,16558,16755],0); -ELEMENTS[77505] = Fluid3D([12891,13207,12227,12538],0); -ELEMENTS[77506] = Fluid3D([13207,12227,12538,12801],0); -ELEMENTS[77507] = Fluid3D([14540,14949,15402,14444],0); -ELEMENTS[77508] = Fluid3D([7409,7129,8204,8515],0); -ELEMENTS[77509] = Fluid3D([14938,13995,14802,13845],0); -ELEMENTS[77510] = Fluid3D([8918,9398,10316,9216],0); -ELEMENTS[77511] = Fluid3D([12747,11968,12845,12975],0); -ELEMENTS[77512] = Fluid3D([10447,10860,11280,10358],0); -ELEMENTS[77513] = Fluid3D([3720,3480,3168,3245],0); -ELEMENTS[77514] = Fluid3D([16241,15888,16070,16577],0); -ELEMENTS[77515] = Fluid3D([9517,9688,8819,8353],0); -ELEMENTS[77516] = Fluid3D([9683,10374,9325,8576],0); -ELEMENTS[77517] = Fluid3D([8506,7493,8075,7731],0); -ELEMENTS[77518] = Fluid3D([13892,13686,12917,12409],0); -ELEMENTS[77519] = Fluid3D([14630,15147,15674,15188],0); -ELEMENTS[77520] = Fluid3D([4372,4814,4430,4949],0); -ELEMENTS[77521] = Fluid3D([4372,4814,4949,4965],0); -ELEMENTS[77522] = Fluid3D([10800,10580,9801,9363],0); -ELEMENTS[77523] = Fluid3D([8124,8228,7545,9062],0); -ELEMENTS[77524] = Fluid3D([8124,8228,9062,9286],0); -ELEMENTS[77525] = Fluid3D([9820,9220,8515,9128],0); -ELEMENTS[77526] = Fluid3D([2999,2820,2910,2532],0); -ELEMENTS[77527] = Fluid3D([18297,18378,18045,18215],0); -ELEMENTS[77528] = Fluid3D([8822,7967,8841,8233],0); -ELEMENTS[77529] = Fluid3D([9734,9927,9241,9030],0); -ELEMENTS[77530] = Fluid3D([16163,15777,15705,15390],0); -ELEMENTS[77531] = Fluid3D([7511,7777,7866,6662],0); -ELEMENTS[77532] = Fluid3D([2498,2784,2674,2948],0); -ELEMENTS[77533] = Fluid3D([3053,3124,2775,2914],0); -ELEMENTS[77534] = Fluid3D([8293,8025,7191,7663],0); -ELEMENTS[77535] = Fluid3D([15131,14641,14548,15403],0); -ELEMENTS[77536] = Fluid3D([6708,6450,5773,6073],0); -ELEMENTS[77537] = Fluid3D([8593,8479,7672,8029],0); -ELEMENTS[77538] = Fluid3D([9329,10200,10369,10005],0); -ELEMENTS[77539] = Fluid3D([13234,12906,13739,13136],0); -ELEMENTS[77540] = Fluid3D([12906,13739,13136,12703],0); -ELEMENTS[77541] = Fluid3D([2725,3019,3073,2772],0); -ELEMENTS[77542] = Fluid3D([4827,5223,5537,5718],0); -ELEMENTS[77543] = Fluid3D([15705,15441,14941,15777],0); -ELEMENTS[77544] = Fluid3D([17207,16812,17171,17347],0); -ELEMENTS[77545] = Fluid3D([2819,3038,3158,3135],0); -ELEMENTS[77546] = Fluid3D([14941,15390,14859,15705],0); -ELEMENTS[77547] = Fluid3D([13483,13422,13311,12501],0); -ELEMENTS[77548] = Fluid3D([18420,18334,18541,18517],0); -ELEMENTS[77549] = Fluid3D([18445,18559,18467,18220],0); -ELEMENTS[77550] = Fluid3D([13428,12792,13992,13307],0); -ELEMENTS[77551] = Fluid3D([12792,13992,13307,13579],0); -ELEMENTS[77552] = Fluid3D([11149,11367,10896,9896],0); -ELEMENTS[77553] = Fluid3D([15095,15449,15183,15895],0); -ELEMENTS[77554] = Fluid3D([7146,7594,6801,6118],0); -ELEMENTS[77555] = Fluid3D([9788,9942,9682,9317],0); -ELEMENTS[77556] = Fluid3D([12036,11014,12181,11904],0); -ELEMENTS[77557] = Fluid3D([7982,8500,9476,8685],0); -ELEMENTS[77558] = Fluid3D([16097,15611,15939,15284],0); -ELEMENTS[77559] = Fluid3D([9061,9959,9893,9766],0); -ELEMENTS[77560] = Fluid3D([12928,13598,14106,13444],0); -ELEMENTS[77561] = Fluid3D([7218,7308,6750,7725],0); -ELEMENTS[77562] = Fluid3D([17099,17228,16669,16929],0); -ELEMENTS[77563] = Fluid3D([6728,6438,6346,6528],0); -ELEMENTS[77564] = Fluid3D([6728,6438,6528,7416],0); -ELEMENTS[77565] = Fluid3D([6728,6438,7416,6861],0); -ELEMENTS[77566] = Fluid3D([7217,7154,7554,7027],0); -ELEMENTS[77567] = Fluid3D([15509,16174,16306,15749],0); -ELEMENTS[77568] = Fluid3D([8741,8204,7363,7969],0); -ELEMENTS[77569] = Fluid3D([8741,8204,7969,9365],0); -ELEMENTS[77570] = Fluid3D([17391,17462,17008,17026],0); -ELEMENTS[77571] = Fluid3D([16663,16266,16997,16498],0); -ELEMENTS[77572] = Fluid3D([16663,16266,16498,16439],0); -ELEMENTS[77573] = Fluid3D([16693,16823,16651,16301],0); -ELEMENTS[77574] = Fluid3D([16693,16823,16301,16993],0); -ELEMENTS[77575] = Fluid3D([9220,10058,9128,9820],0); -ELEMENTS[77576] = Fluid3D([16129,16223,15534,15287],0); -ELEMENTS[77577] = Fluid3D([6738,6152,7090,5974],0); -ELEMENTS[77578] = Fluid3D([7146,7633,7346,6584],0); -ELEMENTS[77579] = Fluid3D([11801,12232,12575,13099],0); -ELEMENTS[77580] = Fluid3D([15818,15535,15732,15046],0); -ELEMENTS[77581] = Fluid3D([1641,1728,1727,1660],0); -ELEMENTS[77582] = Fluid3D([7594,8426,7607,7470],0); -ELEMENTS[77583] = Fluid3D([11795,11824,10969,11298],0); -ELEMENTS[77584] = Fluid3D([2626,2774,3108,3064],0); -ELEMENTS[77585] = Fluid3D([18589,18536,18534,18470],0); -ELEMENTS[77586] = Fluid3D([17753,17481,17257,17381],0); -ELEMENTS[77587] = Fluid3D([12777,12428,12481,13349],0); -ELEMENTS[77588] = Fluid3D([14370,13786,14732,14307],0); -ELEMENTS[77589] = Fluid3D([6005,6788,6020,6879],0); -ELEMENTS[77590] = Fluid3D([6005,6788,6879,6476],0); -ELEMENTS[77591] = Fluid3D([13282,13791,14125,13660],0); -ELEMENTS[77592] = Fluid3D([9597,9776,8608,8379],0); -ELEMENTS[77593] = Fluid3D([9258,9966,8631,9540],0); -ELEMENTS[77594] = Fluid3D([14814,14632,14350,13814],0); -ELEMENTS[77595] = Fluid3D([14814,14632,13814,14252],0); -ELEMENTS[77596] = Fluid3D([11438,10984,10604,11726],0); -ELEMENTS[77597] = Fluid3D([6220,6802,5947,6530],0); -ELEMENTS[77598] = Fluid3D([3787,3550,3523,3911],0); -ELEMENTS[77599] = Fluid3D([3787,3550,3911,4084],0); -ELEMENTS[77600] = Fluid3D([2052,2006,2118,2318],0); -ELEMENTS[77601] = Fluid3D([13817,14562,13958,13587],0); -ELEMENTS[77602] = Fluid3D([11682,12416,12963,12762],0); -ELEMENTS[77603] = Fluid3D([10330,10983,9393,9819],0); -ELEMENTS[77604] = Fluid3D([10330,10983,9819,10618],0); -ELEMENTS[77605] = Fluid3D([5157,5664,4762,4973],0); -ELEMENTS[77606] = Fluid3D([8379,8024,8161,9285],0); -ELEMENTS[77607] = Fluid3D([13734,12706,13256,12884],0); -ELEMENTS[77608] = Fluid3D([15074,15014,14360,14892],0); -ELEMENTS[77609] = Fluid3D([11964,12300,12965,11385],0); -ELEMENTS[77610] = Fluid3D([11964,12300,11385,11217],0); -ELEMENTS[77611] = Fluid3D([8946,8426,8623,8710],0); -ELEMENTS[77612] = Fluid3D([4609,4312,4330,4747],0); -ELEMENTS[77613] = Fluid3D([17932,18174,18008,18315],0); -ELEMENTS[77614] = Fluid3D([6429,5671,6260,6315],0); -ELEMENTS[77615] = Fluid3D([11904,11839,12157,13043],0); -ELEMENTS[77616] = Fluid3D([7665,7454,6618,7457],0); -ELEMENTS[77617] = Fluid3D([10791,10157,9723,9837],0); -ELEMENTS[77618] = Fluid3D([17315,17003,16695,17144],0); -ELEMENTS[77619] = Fluid3D([6477,6039,5664,6179],0); -ELEMENTS[77620] = Fluid3D([5664,6477,6179,5997],0); -ELEMENTS[77621] = Fluid3D([5726,5851,6219,6812],0); -ELEMENTS[77622] = Fluid3D([10922,12052,11269,10718],0); -ELEMENTS[77623] = Fluid3D([4302,4603,3911,4292],0); -ELEMENTS[77624] = Fluid3D([18113,17953,17715,17558],0); -ELEMENTS[77625] = Fluid3D([5288,5569,5222,4825],0); -ELEMENTS[77626] = Fluid3D([7634,7284,6946,7818],0); -ELEMENTS[77627] = Fluid3D([15486,15992,15677,15502],0); -ELEMENTS[77628] = Fluid3D([6955,6126,7401,6821],0); -ELEMENTS[77629] = Fluid3D([15493,15278,14772,15643],0); -ELEMENTS[77630] = Fluid3D([16525,17172,16965,16810],0); -ELEMENTS[77631] = Fluid3D([18355,18486,18220,18467],0); -ELEMENTS[77632] = Fluid3D([17888,18071,17770,17756],0); -ELEMENTS[77633] = Fluid3D([18117,18244,18360,18443],0); -ELEMENTS[77634] = Fluid3D([13466,13532,12911,12664],0); -ELEMENTS[77635] = Fluid3D([17306,17313,16717,16750],0); -ELEMENTS[77636] = Fluid3D([9392,9837,10791,9723],0); -ELEMENTS[77637] = Fluid3D([13492,12422,12601,13650],0); -ELEMENTS[77638] = Fluid3D([4825,4487,5222,5288],0); -ELEMENTS[77639] = Fluid3D([14933,15321,15658,15927],0); -ELEMENTS[77640] = Fluid3D([12801,11591,12227,12538],0); -ELEMENTS[77641] = Fluid3D([1932,1911,2009,2214],0); -ELEMENTS[77642] = Fluid3D([8355,9051,9696,8622],0); -ELEMENTS[77643] = Fluid3D([11849,11927,10869,11781],0); -ELEMENTS[77644] = Fluid3D([15967,16165,15666,15180],0); -ELEMENTS[77645] = Fluid3D([10339,11080,10969,11795],0); -ELEMENTS[77646] = Fluid3D([14938,14943,13995,13845],0); -ELEMENTS[77647] = Fluid3D([7622,8672,7826,8789],0); -ELEMENTS[77648] = Fluid3D([2964,2817,3064,3351],0); -ELEMENTS[77649] = Fluid3D([4330,4348,4312,3995],0); -ELEMENTS[77650] = Fluid3D([12764,13127,13012,13796],0); -ELEMENTS[77651] = Fluid3D([10718,10626,10922,12052],0); -ELEMENTS[77652] = Fluid3D([13073,12190,11743,11921],0); -ELEMENTS[77653] = Fluid3D([17180,17613,17060,17291],0); -ELEMENTS[77654] = Fluid3D([8345,8306,8686,9477],0); -ELEMENTS[77655] = Fluid3D([3726,3938,3621,4172],0); -ELEMENTS[77656] = Fluid3D([11602,12319,12857,12430],0); -ELEMENTS[77657] = Fluid3D([13882,14374,14795,14833],0); -ELEMENTS[77658] = Fluid3D([8285,7302,7674,8186],0); -ELEMENTS[77659] = Fluid3D([17522,17584,17705,17201],0); -ELEMENTS[77660] = Fluid3D([12501,12448,13172,13483],0); -ELEMENTS[77661] = Fluid3D([11891,10818,11077,11433],0); -ELEMENTS[77662] = Fluid3D([15842,16260,15831,16447],0); -ELEMENTS[77663] = Fluid3D([10156,10652,10874,9961],0); -ELEMENTS[77664] = Fluid3D([15553,16098,15697,16394],0); -ELEMENTS[77665] = Fluid3D([9527,10271,9812,10830],0); -ELEMENTS[77666] = Fluid3D([16540,16249,15826,15888],0); -ELEMENTS[77667] = Fluid3D([7544,7275,7362,6350],0); -ELEMENTS[77668] = Fluid3D([12675,12881,12020,11387],0); -ELEMENTS[77669] = Fluid3D([10978,11874,10357,11582],0); -ELEMENTS[77670] = Fluid3D([4015,3795,3780,3306],0); -ELEMENTS[77671] = Fluid3D([3036,2743,2792,3248],0); -ELEMENTS[77672] = Fluid3D([2635,2998,3148,2892],0); -ELEMENTS[77673] = Fluid3D([11146,11537,10786,10185],0); -ELEMENTS[77674] = Fluid3D([3458,3578,3140,2955],0); -ELEMENTS[77675] = Fluid3D([7954,7725,8792,8446],0); -ELEMENTS[77676] = Fluid3D([5598,4928,5084,5027],0); -ELEMENTS[77677] = Fluid3D([16499,16305,16486,15933],0); -ELEMENTS[77678] = Fluid3D([8067,8502,7241,7487],0); -ELEMENTS[77679] = Fluid3D([12116,12408,13434,13170],0); -ELEMENTS[77680] = Fluid3D([16379,16441,16706,16806],0); -ELEMENTS[77681] = Fluid3D([14816,14358,14946,14951],0); -ELEMENTS[77682] = Fluid3D([17196,16974,16913,16519],0); -ELEMENTS[77683] = Fluid3D([16089,15933,16486,16305],0); -ELEMENTS[77684] = Fluid3D([13571,13428,14300,14598],0); -ELEMENTS[77685] = Fluid3D([13693,12824,12674,13518],0); -ELEMENTS[77686] = Fluid3D([7657,7194,7471,7678],0); -ELEMENTS[77687] = Fluid3D([14124,13918,13138,13780],0); -ELEMENTS[77688] = Fluid3D([6206,6744,6627,6138],0); -ELEMENTS[77689] = Fluid3D([11331,12157,11315,11839],0); -ELEMENTS[77690] = Fluid3D([18267,18408,18270,18354],0); -ELEMENTS[77691] = Fluid3D([15739,15261,15305,15049],0); -ELEMENTS[77692] = Fluid3D([11135,10142,11164,10928],0); -ELEMENTS[77693] = Fluid3D([18608,18578,18662,18643],0); -ELEMENTS[77694] = Fluid3D([13250,14401,14117,14446],0); -ELEMENTS[77695] = Fluid3D([4912,4593,4022,4352],0); -ELEMENTS[77696] = Fluid3D([14795,14127,13882,14833],0); -ELEMENTS[77697] = Fluid3D([16412,16765,16821,16063],0); -ELEMENTS[77698] = Fluid3D([5087,4294,4417,5107],0); -ELEMENTS[77699] = Fluid3D([7725,8084,6968,6900],0); -ELEMENTS[77700] = Fluid3D([18241,18192,18441,18332],0); -ELEMENTS[77701] = Fluid3D([4081,3608,3570,4118],0); -ELEMENTS[77702] = Fluid3D([8519,8723,9507,8583],0); -ELEMENTS[77703] = Fluid3D([17136,17515,17619,17168],0); -ELEMENTS[77704] = Fluid3D([12322,13023,11901,12527],0); -ELEMENTS[77705] = Fluid3D([7662,8439,7614,7538],0); -ELEMENTS[77706] = Fluid3D([7614,7662,7538,6797],0); -ELEMENTS[77707] = Fluid3D([7614,7662,6797,7647],0); -ELEMENTS[77708] = Fluid3D([18621,18559,18486,18582],0); -ELEMENTS[77709] = Fluid3D([8145,8921,9521,8335],0); -ELEMENTS[77710] = Fluid3D([9440,8075,8622,9051],0); -ELEMENTS[77711] = Fluid3D([15209,15749,15931,15648],0); -ELEMENTS[77712] = Fluid3D([12587,11775,12855,12418],0); -ELEMENTS[77713] = Fluid3D([16220,15820,15468,15191],0); -ELEMENTS[77714] = Fluid3D([14792,14306,13973,13470],0); -ELEMENTS[77715] = Fluid3D([4477,4060,4571,4804],0); -ELEMENTS[77716] = Fluid3D([2928,2778,2872,3206],0); -ELEMENTS[77717] = Fluid3D([4186,4685,4759,4377],0); -ELEMENTS[77718] = Fluid3D([17576,17463,17033,17120],0); -ELEMENTS[77719] = Fluid3D([5535,5506,6156,5508],0); -ELEMENTS[77720] = Fluid3D([12674,12246,13219,12658],0); -ELEMENTS[77721] = Fluid3D([10364,9969,9950,8979],0); -ELEMENTS[77722] = Fluid3D([13815,13136,12907,13234],0); -ELEMENTS[77723] = Fluid3D([4312,4622,4348,4747],0); -ELEMENTS[77724] = Fluid3D([8178,8311,7510,7190],0); -ELEMENTS[77725] = Fluid3D([3246,3670,3553,3330],0); -ELEMENTS[77726] = Fluid3D([5458,6134,5335,5957],0); -ELEMENTS[77727] = Fluid3D([12652,13334,11952,12273],0); -ELEMENTS[77728] = Fluid3D([8946,10232,9129,9527],0); -ELEMENTS[77729] = Fluid3D([2778,2744,2872,3206],0); -ELEMENTS[77730] = Fluid3D([13780,13649,14242,13918],0); -ELEMENTS[77731] = Fluid3D([15770,16023,15502,15677],0); -ELEMENTS[77732] = Fluid3D([4506,4390,4839,4159],0); -ELEMENTS[77733] = Fluid3D([13222,12981,13399,12149],0); -ELEMENTS[77734] = Fluid3D([13819,14731,14464,14438],0); -ELEMENTS[77735] = Fluid3D([6503,7314,7167,7623],0); -ELEMENTS[77736] = Fluid3D([5188,5576,6131,5804],0); -ELEMENTS[77737] = Fluid3D([2346,2383,2144,2235],0); -ELEMENTS[77738] = Fluid3D([6044,5476,6283,6087],0); -ELEMENTS[77739] = Fluid3D([7969,7036,7396,6572],0); -ELEMENTS[77740] = Fluid3D([7741,7078,8115,7190],0); -ELEMENTS[77741] = Fluid3D([9217,8299,8895,8745],0); -ELEMENTS[77742] = Fluid3D([17690,17655,17325,17176],0); -ELEMENTS[77743] = Fluid3D([7213,6347,7333,6442],0); -ELEMENTS[77744] = Fluid3D([2721,2466,2374,2273],0); -ELEMENTS[77745] = Fluid3D([8389,8265,8863,7871],0); -ELEMENTS[77746] = Fluid3D([17756,18023,18071,17770],0); -ELEMENTS[77747] = Fluid3D([18081,17752,18097,18088],0); -ELEMENTS[77748] = Fluid3D([15052,14501,14834,14427],0); -ELEMENTS[77749] = Fluid3D([13835,13108,13952,13098],0); -ELEMENTS[77750] = Fluid3D([13835,13108,13098,12708],0); -ELEMENTS[77751] = Fluid3D([3525,3655,3660,3367],0); -ELEMENTS[77752] = Fluid3D([3525,3655,3367,3383],0); -ELEMENTS[77753] = Fluid3D([7623,7275,6639,7051],0); -ELEMENTS[77754] = Fluid3D([17834,18079,18256,18150],0); -ELEMENTS[77755] = Fluid3D([12174,11565,11108,11336],0); -ELEMENTS[77756] = Fluid3D([9188,8583,8723,7825],0); -ELEMENTS[77757] = Fluid3D([4136,3926,3505,3494],0); -ELEMENTS[77758] = Fluid3D([5124,5323,5864,5828],0); -ELEMENTS[77759] = Fluid3D([10964,9802,10282,10514],0); -ELEMENTS[77760] = Fluid3D([13894,13369,14498,14601],0); -ELEMENTS[77761] = Fluid3D([10157,10293,11171,9723],0); -ELEMENTS[77762] = Fluid3D([10674,9398,10678,10316],0); -ELEMENTS[77763] = Fluid3D([5395,5951,5515,4934],0); -ELEMENTS[77764] = Fluid3D([7777,7698,7866,6736],0); -ELEMENTS[77765] = Fluid3D([2784,2611,3072,2948],0); -ELEMENTS[77766] = Fluid3D([3696,4007,3358,3476],0); -ELEMENTS[77767] = Fluid3D([12427,13224,12419,11975],0); -ELEMENTS[77768] = Fluid3D([6801,6232,6118,7594],0); -ELEMENTS[77769] = Fluid3D([7376,7419,6667,7461],0); -ELEMENTS[77770] = Fluid3D([2743,2828,2792,2468],0); -ELEMENTS[77771] = Fluid3D([3754,3672,3334,3905],0); -ELEMENTS[77772] = Fluid3D([3805,3866,4040,4542],0); -ELEMENTS[77773] = Fluid3D([1660,1575,1727,1641],0); -ELEMENTS[77774] = Fluid3D([14564,13863,14849,14337],0); -ELEMENTS[77775] = Fluid3D([4181,3780,4442,4305],0); -ELEMENTS[77776] = Fluid3D([4280,3837,4281,4294],0); -ELEMENTS[77777] = Fluid3D([8910,9286,9062,8228],0); -ELEMENTS[77778] = Fluid3D([13999,14275,13693,13518],0); -ELEMENTS[77779] = Fluid3D([12549,12015,12831,13525],0); -ELEMENTS[77780] = Fluid3D([17145,16993,16693,16601],0); -ELEMENTS[77781] = Fluid3D([10696,9567,10550,10599],0); -ELEMENTS[77782] = Fluid3D([12519,11444,11868,12466],0); -ELEMENTS[77783] = Fluid3D([6476,5992,6879,6005],0); -ELEMENTS[77784] = Fluid3D([11108,12174,11336,12538],0); -ELEMENTS[77785] = Fluid3D([2407,2272,2598,2910],0); -ELEMENTS[77786] = Fluid3D([2301,2582,2735,2451],0); -ELEMENTS[77787] = Fluid3D([11367,10776,10896,9896],0); -ELEMENTS[77788] = Fluid3D([17337,16889,17532,17080],0); -ELEMENTS[77789] = Fluid3D([11676,12433,12457,11556],0); -ELEMENTS[77790] = Fluid3D([8475,9236,9120,7908],0); -ELEMENTS[77791] = Fluid3D([4757,5542,4957,4940],0); -ELEMENTS[77792] = Fluid3D([2548,2296,2710,2650],0); -ELEMENTS[77793] = Fluid3D([10185,9898,10651,11537],0); -ELEMENTS[77794] = Fluid3D([13504,13586,13827,14444],0); -ELEMENTS[77795] = Fluid3D([4023,3623,4205,4071],0); -ELEMENTS[77796] = Fluid3D([15848,15645,14892,15002],0); -ELEMENTS[77797] = Fluid3D([13053,13027,13691,14141],0); -ELEMENTS[77798] = Fluid3D([16819,17149,17072,16948],0); -ELEMENTS[77799] = Fluid3D([7537,7881,6680,7127],0); -ELEMENTS[77800] = Fluid3D([15905,15898,16070,16628],0); -ELEMENTS[77801] = Fluid3D([5106,5244,4742,5612],0); -ELEMENTS[77802] = Fluid3D([12625,12157,12921,13504],0); -ELEMENTS[77803] = Fluid3D([2717,2703,2366,2415],0); -ELEMENTS[77804] = Fluid3D([17843,18025,18057,18220],0); -ELEMENTS[77805] = Fluid3D([14649,15169,14502,14586],0); -ELEMENTS[77806] = Fluid3D([9699,9321,9741,9095],0); -ELEMENTS[77807] = Fluid3D([5798,6251,6661,6248],0); -ELEMENTS[77808] = Fluid3D([14501,14715,13445,13812],0); -ELEMENTS[77809] = Fluid3D([13445,14501,13812,13410],0); -ELEMENTS[77810] = Fluid3D([10188,10922,10626,11662],0); -ELEMENTS[77811] = Fluid3D([10922,10626,11662,12052],0); -ELEMENTS[77812] = Fluid3D([16952,16569,16690,16613],0); -ELEMENTS[77813] = Fluid3D([2385,2288,2263,2568],0); -ELEMENTS[77814] = Fluid3D([3967,3770,3895,4372],0); -ELEMENTS[77815] = Fluid3D([5282,5603,6038,5522],0); -ELEMENTS[77816] = Fluid3D([9710,9590,10362,9377],0); -ELEMENTS[77817] = Fluid3D([18439,18334,18307,18517],0); -ELEMENTS[77818] = Fluid3D([10099,10604,10193,11726],0); -ELEMENTS[77819] = Fluid3D([11092,9883,11270,10297],0); -ELEMENTS[77820] = Fluid3D([11797,12257,13299,12887],0); -ELEMENTS[77821] = Fluid3D([6886,7814,7477,6444],0); -ELEMENTS[77822] = Fluid3D([2960,3314,3061,2628],0); -ELEMENTS[77823] = Fluid3D([2200,2214,2210,2032],0); -ELEMENTS[77824] = Fluid3D([2844,3053,2648,2542],0); -ELEMENTS[77825] = Fluid3D([11775,12587,11900,12418],0); -ELEMENTS[77826] = Fluid3D([5671,6429,5845,6602],0); -ELEMENTS[77827] = Fluid3D([15091,14741,14891,14182],0); -ELEMENTS[77828] = Fluid3D([14311,14025,15072,14764],0); -ELEMENTS[77829] = Fluid3D([15888,16018,15826,16540],0); -ELEMENTS[77830] = Fluid3D([9707,10055,10771,11188],0); -ELEMENTS[77831] = Fluid3D([16775,17030,16877,16304],0); -ELEMENTS[77832] = Fluid3D([17943,18098,17747,17731],0); -ELEMENTS[77833] = Fluid3D([4288,4339,3642,3893],0); -ELEMENTS[77834] = Fluid3D([2009,2152,1915,1932],0); -ELEMENTS[77835] = Fluid3D([7628,7726,7501,6949],0); -ELEMENTS[77836] = Fluid3D([7726,7501,6949,7213],0); -ELEMENTS[77837] = Fluid3D([8268,8642,8587,9226],0); -ELEMENTS[77838] = Fluid3D([3826,4154,4639,4326],0); -ELEMENTS[77839] = Fluid3D([14309,14582,15114,15551],0); -ELEMENTS[77840] = Fluid3D([16652,16961,17036,17096],0); -ELEMENTS[77841] = Fluid3D([11687,12372,12301,11614],0); -ELEMENTS[77842] = Fluid3D([2928,3291,3138,3060],0); -ELEMENTS[77843] = Fluid3D([7465,6984,7572,8246],0); -ELEMENTS[77844] = Fluid3D([13091,13905,14197,12936],0); -ELEMENTS[77845] = Fluid3D([9051,8506,8075,7731],0); -ELEMENTS[77846] = Fluid3D([17485,17603,17415,17872],0); -ELEMENTS[77847] = Fluid3D([7147,6368,6251,6711],0); -ELEMENTS[77848] = Fluid3D([11198,11470,12281,12138],0); -ELEMENTS[77849] = Fluid3D([2981,3175,3548,3300],0); -ELEMENTS[77850] = Fluid3D([9130,8621,8165,8073],0); -ELEMENTS[77851] = Fluid3D([14760,14710,14724,15348],0); -ELEMENTS[77852] = Fluid3D([8322,8284,9587,9215],0); -ELEMENTS[77853] = Fluid3D([10180,10040,9284,10512],0); -ELEMENTS[77854] = Fluid3D([10180,10040,10512,11513],0); -ELEMENTS[77855] = Fluid3D([16898,16836,17136,16504],0); -ELEMENTS[77856] = Fluid3D([18450,18501,18590,18437],0); -ELEMENTS[77857] = Fluid3D([4703,5142,4873,4754],0); -ELEMENTS[77858] = Fluid3D([9377,10362,9140,9590],0); -ELEMENTS[77859] = Fluid3D([13501,13819,13441,14464],0); -ELEMENTS[77860] = Fluid3D([8337,7936,9393,9230],0); -ELEMENTS[77861] = Fluid3D([13138,12575,13918,13618],0); -ELEMENTS[77862] = Fluid3D([11163,11537,11839,10470],0); -ELEMENTS[77863] = Fluid3D([6835,6190,5981,6523],0); -ELEMENTS[77864] = Fluid3D([14608,14893,14300,15535],0); -ELEMENTS[77865] = Fluid3D([13157,13633,12876,13337],0); -ELEMENTS[77866] = Fluid3D([16987,16686,17272,17057],0); -ELEMENTS[77867] = Fluid3D([5573,5144,5790,6004],0); -ELEMENTS[77868] = Fluid3D([14227,14991,14767,14662],0); -ELEMENTS[77869] = Fluid3D([9128,10058,9103,9820],0); -ELEMENTS[77870] = Fluid3D([17147,17250,17374,16745],0); -ELEMENTS[77871] = Fluid3D([9143,8745,9962,10479],0); -ELEMENTS[77872] = Fluid3D([14596,14639,13999,13578],0); -ELEMENTS[77873] = Fluid3D([2214,2200,2009,1932],0); -ELEMENTS[77874] = Fluid3D([8447,7567,8305,8735],0); -ELEMENTS[77875] = Fluid3D([11519,11622,12609,11708],0); -ELEMENTS[77876] = Fluid3D([8786,9289,8124,9286],0); -ELEMENTS[77877] = Fluid3D([17048,17230,17234,17630],0); -ELEMENTS[77878] = Fluid3D([14938,14863,14960,13842],0); -ELEMENTS[77879] = Fluid3D([18082,18260,18210,18380],0); -ELEMENTS[77880] = Fluid3D([16372,16303,16389,16948],0); -ELEMENTS[77881] = Fluid3D([16525,16362,15801,15921],0); -ELEMENTS[77882] = Fluid3D([2373,2300,2041,2229],0); -ELEMENTS[77883] = Fluid3D([17099,16753,16456,16669],0); -ELEMENTS[77884] = Fluid3D([12128,11044,12260,11979],0); -ELEMENTS[77885] = Fluid3D([10180,11102,11513,11436],0); -ELEMENTS[77886] = Fluid3D([4222,4352,4912,4022],0); -ELEMENTS[77887] = Fluid3D([4222,4352,4022,3589],0); -ELEMENTS[77888] = Fluid3D([18486,18582,18576,18621],0); -ELEMENTS[77889] = Fluid3D([11183,12055,11016,11230],0); -ELEMENTS[77890] = Fluid3D([16381,15916,16499,16362],0); -ELEMENTS[77891] = Fluid3D([17149,16819,16806,16948],0); -ELEMENTS[77892] = Fluid3D([15416,14743,15405,15632],0); -ELEMENTS[77893] = Fluid3D([18400,18423,18216,18381],0); -ELEMENTS[77894] = Fluid3D([16766,16180,16539,16177],0); -ELEMENTS[77895] = Fluid3D([6639,7167,7623,6503],0); -ELEMENTS[77896] = Fluid3D([15054,15670,15774,15056],0); -ELEMENTS[77897] = Fluid3D([14947,14459,13952,14612],0); -ELEMENTS[77898] = Fluid3D([4105,4641,4449,4459],0); -ELEMENTS[77899] = Fluid3D([18244,18008,18067,18280],0); -ELEMENTS[77900] = Fluid3D([14696,14023,14126,13295],0); -ELEMENTS[77901] = Fluid3D([4983,5449,5613,5754],0); -ELEMENTS[77902] = Fluid3D([17050,17016,17158,16660],0); -ELEMENTS[77903] = Fluid3D([3480,3158,3168,3245],0); -ELEMENTS[77904] = Fluid3D([12911,13459,13022,13532],0); -ELEMENTS[77905] = Fluid3D([9120,8132,7908,9117],0); -ELEMENTS[77906] = Fluid3D([2979,2962,3292,3049],0); -ELEMENTS[77907] = Fluid3D([18038,17884,17722,17813],0); -ELEMENTS[77908] = Fluid3D([12253,12043,11424,10874],0); -ELEMENTS[77909] = Fluid3D([11601,10699,11424,11687],0); -ELEMENTS[77910] = Fluid3D([16898,16750,16667,17163],0); -ELEMENTS[77911] = Fluid3D([15924,15597,15861,15071],0); -ELEMENTS[77912] = Fluid3D([6770,6366,5950,6696],0); -ELEMENTS[77913] = Fluid3D([9847,10894,10848,10595],0); -ELEMENTS[77914] = Fluid3D([10313,10561,11392,11541],0); -ELEMENTS[77915] = Fluid3D([1721,1879,1818,1804],0); -ELEMENTS[77916] = Fluid3D([12399,13283,12357,12610],0); -ELEMENTS[77917] = Fluid3D([3362,3077,3675,3437],0); -ELEMENTS[77918] = Fluid3D([18181,18066,17751,18005],0); -ELEMENTS[77919] = Fluid3D([16200,16381,16525,16362],0); -ELEMENTS[77920] = Fluid3D([2568,2649,2288,2276],0); -ELEMENTS[77921] = Fluid3D([2590,2979,3128,2710],0); -ELEMENTS[77922] = Fluid3D([7393,7113,6490,6174],0); -ELEMENTS[77923] = Fluid3D([16362,15939,15801,15284],0); -ELEMENTS[77924] = Fluid3D([12124,12901,11981,12887],0); -ELEMENTS[77925] = Fluid3D([5671,6429,6602,6315],0); -ELEMENTS[77926] = Fluid3D([12182,12911,13022,13532],0); -ELEMENTS[77927] = Fluid3D([12762,12963,13524,12416],0); -ELEMENTS[77928] = Fluid3D([12623,13408,12286,13037],0); -ELEMENTS[77929] = Fluid3D([11862,12451,13099,12798],0); -ELEMENTS[77930] = Fluid3D([10805,11063,9724,9612],0); -ELEMENTS[77931] = Fluid3D([18440,18426,18415,18580],0); -ELEMENTS[77932] = Fluid3D([10350,9173,9521,9728],0); -ELEMENTS[77933] = Fluid3D([11785,12416,12716,13202],0); -ELEMENTS[77934] = Fluid3D([6707,6413,7026,7582],0); -ELEMENTS[77935] = Fluid3D([15300,14586,15169,14476],0); -ELEMENTS[77936] = Fluid3D([14893,14598,13571,14300],0); -ELEMENTS[77937] = Fluid3D([14893,14598,14300,15535],0); -ELEMENTS[77938] = Fluid3D([3860,3730,3431,3916],0); -ELEMENTS[77939] = Fluid3D([3908,3518,3592,3289],0); -ELEMENTS[77940] = Fluid3D([3908,3518,3289,3692],0); -ELEMENTS[77941] = Fluid3D([18567,18513,18411,18510],0); -ELEMENTS[77942] = Fluid3D([3480,3720,3639,3245],0); -ELEMENTS[77943] = Fluid3D([8649,9517,8819,8353],0); -ELEMENTS[77944] = Fluid3D([13708,13355,12507,12607],0); -ELEMENTS[77945] = Fluid3D([6802,7711,7126,7299],0); -ELEMENTS[77946] = Fluid3D([16968,17270,16837,17008],0); -ELEMENTS[77947] = Fluid3D([12979,12615,12237,12504],0); -ELEMENTS[77948] = Fluid3D([3528,3560,3982,3590],0); -ELEMENTS[77949] = Fluid3D([16464,16443,17124,17106],0); -ELEMENTS[77950] = Fluid3D([16702,16689,17327,17153],0); -ELEMENTS[77951] = Fluid3D([2527,2805,2817,2485],0); -ELEMENTS[77952] = Fluid3D([14617,14379,15175,14321],0); -ELEMENTS[77953] = Fluid3D([3618,4044,3814,3894],0); -ELEMENTS[77954] = Fluid3D([8484,8433,8293,9188],0); -ELEMENTS[77955] = Fluid3D([17387,17401,17224,16805],0); -ELEMENTS[77956] = Fluid3D([18485,18518,18573,18453],0); -ELEMENTS[77957] = Fluid3D([13099,12206,13618,12575],0); -ELEMENTS[77958] = Fluid3D([15944,16365,16368,16570],0); -ELEMENTS[77959] = Fluid3D([16446,16689,16457,17153],0); -ELEMENTS[77960] = Fluid3D([2817,3064,3351,3223],0); -ELEMENTS[77961] = Fluid3D([6118,5977,6255,7146],0); -ELEMENTS[77962] = Fluid3D([10776,9788,9709,9896],0); -ELEMENTS[77963] = Fluid3D([3851,4068,3843,3607],0); -ELEMENTS[77964] = Fluid3D([3851,4068,3607,3907],0); -ELEMENTS[77965] = Fluid3D([15361,14583,15190,14231],0); -ELEMENTS[77966] = Fluid3D([4899,5005,5038,4385],0); -ELEMENTS[77967] = Fluid3D([17234,17630,17571,17048],0); -ELEMENTS[77968] = Fluid3D([12975,12308,11508,11968],0); -ELEMENTS[77969] = Fluid3D([6061,5606,5848,5531],0); -ELEMENTS[77970] = Fluid3D([10374,9683,9404,8576],0); -ELEMENTS[77971] = Fluid3D([14410,13923,13354,13334],0); -ELEMENTS[77972] = Fluid3D([11293,12238,11904,11014],0); -ELEMENTS[77973] = Fluid3D([16255,16601,15737,16278],0); -ELEMENTS[77974] = Fluid3D([10284,10558,11362,10889],0); -ELEMENTS[77975] = Fluid3D([5084,5670,5320,5760],0); -ELEMENTS[77976] = Fluid3D([11442,11868,12519,11620],0); -ELEMENTS[77977] = Fluid3D([4135,3905,3680,3546],0); -ELEMENTS[77978] = Fluid3D([3905,3680,3546,3334],0); -ELEMENTS[77979] = Fluid3D([14086,14360,14637,14856],0); -ELEMENTS[77980] = Fluid3D([8898,8906,8662,7932],0); -ELEMENTS[77981] = Fluid3D([16330,16251,15767,15914],0); -ELEMENTS[77982] = Fluid3D([6872,7428,7361,8179],0); -ELEMENTS[77983] = Fluid3D([18408,18325,18079,18270],0); -ELEMENTS[77984] = Fluid3D([7372,6523,6190,6835],0); -ELEMENTS[77985] = Fluid3D([14427,14112,15028,15190],0); -ELEMENTS[77986] = Fluid3D([16098,15697,16394,16125],0); -ELEMENTS[77987] = Fluid3D([18610,18641,18565,18574],0); -ELEMENTS[77988] = Fluid3D([11969,11146,10786,10571],0); -ELEMENTS[77989] = Fluid3D([7454,7665,8372,7457],0); -ELEMENTS[77990] = Fluid3D([8439,7614,7538,8891],0); -ELEMENTS[77991] = Fluid3D([6347,6765,7333,6442],0); -ELEMENTS[77992] = Fluid3D([14258,14464,13316,13406],0); -ELEMENTS[77993] = Fluid3D([17569,17447,17225,17164],0); -ELEMENTS[77994] = Fluid3D([7937,8429,8323,8161],0); -ELEMENTS[77995] = Fluid3D([13205,12478,13589,13179],0); -ELEMENTS[77996] = Fluid3D([13851,14514,13866,14279],0); -ELEMENTS[77997] = Fluid3D([15321,14933,15877,15927],0); -ELEMENTS[77998] = Fluid3D([9877,10391,9178,8849],0); -ELEMENTS[77999] = Fluid3D([6333,6297,6250,5661],0); -ELEMENTS[78000] = Fluid3D([7936,7373,7051,7624],0); -ELEMENTS[78001] = Fluid3D([12755,13382,13928,13494],0); -ELEMENTS[78002] = Fluid3D([14720,14339,15440,14995],0); -ELEMENTS[78003] = Fluid3D([13740,14501,14427,14834],0); -ELEMENTS[78004] = Fluid3D([5828,5810,5864,5124],0); -ELEMENTS[78005] = Fluid3D([5715,5385,5740,6363],0); -ELEMENTS[78006] = Fluid3D([5578,5715,5740,6363],0); -ELEMENTS[78007] = Fluid3D([12920,13607,13587,14174],0); -ELEMENTS[78008] = Fluid3D([16339,15713,15690,15838],0); -ELEMENTS[78009] = Fluid3D([8737,8585,9773,9620],0); -ELEMENTS[78010] = Fluid3D([13485,12496,13161,12943],0); -ELEMENTS[78011] = Fluid3D([18249,18177,18220,18057],0); -ELEMENTS[78012] = Fluid3D([12523,12380,11049,11345],0); -ELEMENTS[78013] = Fluid3D([8247,8792,8556,7725],0); -ELEMENTS[78014] = Fluid3D([8247,8792,7725,7826],0); -ELEMENTS[78015] = Fluid3D([8265,7678,7657,7871],0); -ELEMENTS[78016] = Fluid3D([10923,10825,9780,9832],0); -ELEMENTS[78017] = Fluid3D([3381,3783,3692,3646],0); -ELEMENTS[78018] = Fluid3D([7848,7808,8791,8178],0); -ELEMENTS[78019] = Fluid3D([1989,2038,2250,2019],0); -ELEMENTS[78020] = Fluid3D([15122,15445,15917,16062],0); -ELEMENTS[78021] = Fluid3D([7958,7983,8046,8934],0); -ELEMENTS[78022] = Fluid3D([12686,13596,12678,13175],0); -ELEMENTS[78023] = Fluid3D([14461,14419,14702,13746],0); -ELEMENTS[78024] = Fluid3D([17505,17173,17444,17589],0); -ELEMENTS[78025] = Fluid3D([16663,16310,16152,15718],0); -ELEMENTS[78026] = Fluid3D([6985,8096,6923,7316],0); -ELEMENTS[78027] = Fluid3D([8847,9637,9247,9279],0); -ELEMENTS[78028] = Fluid3D([12973,13491,13910,14129],0); -ELEMENTS[78029] = Fluid3D([12973,13491,14129,13400],0); -ELEMENTS[78030] = Fluid3D([18086,18004,17860,17720],0); -ELEMENTS[78031] = Fluid3D([7360,8089,7849,8794],0); -ELEMENTS[78032] = Fluid3D([14693,14548,15536,15131],0); -ELEMENTS[78033] = Fluid3D([13003,12407,12684,11632],0); -ELEMENTS[78034] = Fluid3D([14977,14459,14947,14612],0); -ELEMENTS[78035] = Fluid3D([17768,17873,17415,17603],0); -ELEMENTS[78036] = Fluid3D([17867,17648,17633,18068],0); -ELEMENTS[78037] = Fluid3D([2001,2086,1839,1928],0); -ELEMENTS[78038] = Fluid3D([7921,7829,7112,6953],0); -ELEMENTS[78039] = Fluid3D([16230,15671,15717,16413],0); -ELEMENTS[78040] = Fluid3D([5959,6617,6038,5948],0); -ELEMENTS[78041] = Fluid3D([8452,8908,9697,10181],0); -ELEMENTS[78042] = Fluid3D([16736,16858,16500,15927],0); -ELEMENTS[78043] = Fluid3D([16806,17301,17105,16897],0); -ELEMENTS[78044] = Fluid3D([8043,8735,7567,8447],0); -ELEMENTS[78045] = Fluid3D([8524,7750,8302,7082],0); -ELEMENTS[78046] = Fluid3D([10360,9666,9927,9734],0); -ELEMENTS[78047] = Fluid3D([15924,15270,15071,15309],0); -ELEMENTS[78048] = Fluid3D([2638,2537,2260,2644],0); -ELEMENTS[78049] = Fluid3D([8471,9506,9377,9179],0); -ELEMENTS[78050] = Fluid3D([12428,12777,13718,13349],0); -ELEMENTS[78051] = Fluid3D([11418,12139,11862,12798],0); -ELEMENTS[78052] = Fluid3D([4109,3667,4296,3681],0); -ELEMENTS[78053] = Fluid3D([6736,6662,7866,7777],0); -ELEMENTS[78054] = Fluid3D([10984,10193,10604,11726],0); -ELEMENTS[78055] = Fluid3D([4889,4292,4603,4302],0); -ELEMENTS[78056] = Fluid3D([11505,11213,10517,10497],0); -ELEMENTS[78057] = Fluid3D([11505,11213,10497,11658],0); -ELEMENTS[78058] = Fluid3D([10287,10344,9375,8866],0); -ELEMENTS[78059] = Fluid3D([10520,9513,9481,10867],0); -ELEMENTS[78060] = Fluid3D([4442,4871,4015,4498],0); -ELEMENTS[78061] = Fluid3D([16935,17540,17473,16839],0); -ELEMENTS[78062] = Fluid3D([18363,18130,18287,18276],0); -ELEMENTS[78063] = Fluid3D([16122,16445,15977,15545],0); -ELEMENTS[78064] = Fluid3D([5914,5391,6044,5476],0); -ELEMENTS[78065] = Fluid3D([14933,15424,15877,15927],0); -ELEMENTS[78066] = Fluid3D([9128,9103,8515,9820],0); -ELEMENTS[78067] = Fluid3D([4136,3926,3494,4003],0); -ELEMENTS[78068] = Fluid3D([15892,16160,16555,16364],0); -ELEMENTS[78069] = Fluid3D([7191,7663,7825,8293],0); -ELEMENTS[78070] = Fluid3D([16574,17040,16446,16693],0); -ELEMENTS[78071] = Fluid3D([5278,5313,4963,5804],0); -ELEMENTS[78072] = Fluid3D([7676,7969,7396,8204],0); -ELEMENTS[78073] = Fluid3D([14147,13337,12876,13633],0); -ELEMENTS[78074] = Fluid3D([7731,8355,8622,9051],0); -ELEMENTS[78075] = Fluid3D([9224,10194,10587,10298],0); -ELEMENTS[78076] = Fluid3D([12572,12061,12056,12569],0); -ELEMENTS[78077] = Fluid3D([15418,14984,14271,14676],0); -ELEMENTS[78078] = Fluid3D([5684,5765,5249,5950],0); -ELEMENTS[78079] = Fluid3D([10959,12215,11623,10384],0); -ELEMENTS[78080] = Fluid3D([5065,4477,4571,4804],0); -ELEMENTS[78081] = Fluid3D([4442,4305,4754,4181],0); -ELEMENTS[78082] = Fluid3D([10142,9510,9962,10928],0); -ELEMENTS[78083] = Fluid3D([8849,9607,9902,10391],0); -ELEMENTS[78084] = Fluid3D([4791,4215,4691,4743],0); -ELEMENTS[78085] = Fluid3D([9456,9437,8704,9484],0); -ELEMENTS[78086] = Fluid3D([11336,11591,12538,12227],0); -ELEMENTS[78087] = Fluid3D([11336,11591,12227,11118],0); -ELEMENTS[78088] = Fluid3D([12538,11336,12227,11823],0); -ELEMENTS[78089] = Fluid3D([10969,10077,9367,10031],0); -ELEMENTS[78090] = Fluid3D([9398,9187,10316,10829],0); -ELEMENTS[78091] = Fluid3D([10316,9398,10829,10674],0); -ELEMENTS[78092] = Fluid3D([14816,14696,13776,14085],0); -ELEMENTS[78093] = Fluid3D([10827,9679,10326,9884],0); -ELEMENTS[78094] = Fluid3D([2710,2812,2650,3159],0); -ELEMENTS[78095] = Fluid3D([11440,10672,11908,11433],0); -ELEMENTS[78096] = Fluid3D([17066,17444,17173,17589],0); -ELEMENTS[78097] = Fluid3D([17066,17444,17589,17335],0); -ELEMENTS[78098] = Fluid3D([13811,14400,13806,14791],0); -ELEMENTS[78099] = Fluid3D([3009,3156,2636,2846],0); -ELEMENTS[78100] = Fluid3D([8433,8293,9188,7825],0); -ELEMENTS[78101] = Fluid3D([11925,12693,13209,12991],0); -ELEMENTS[78102] = Fluid3D([7326,8102,7443,8745],0); -ELEMENTS[78103] = Fluid3D([14707,14953,15396,15632],0); -ELEMENTS[78104] = Fluid3D([10436,10091,10398,9392],0); -ELEMENTS[78105] = Fluid3D([14075,13825,12876,13076],0); -ELEMENTS[78106] = Fluid3D([5864,5822,5124,5810],0); -ELEMENTS[78107] = Fluid3D([3560,3157,3187,3285],0); -ELEMENTS[78108] = Fluid3D([15654,15934,16374,16158],0); -ELEMENTS[78109] = Fluid3D([16139,15667,15974,15360],0); -ELEMENTS[78110] = Fluid3D([10182,9176,9932,10821],0); -ELEMENTS[78111] = Fluid3D([2568,2263,2320,2288],0); -ELEMENTS[78112] = Fluid3D([14444,14699,13827,13857],0); -ELEMENTS[78113] = Fluid3D([17729,17542,17398,17487],0); -ELEMENTS[78114] = Fluid3D([10946,10993,10343,11483],0); -ELEMENTS[78115] = Fluid3D([11444,11310,10469,11868],0); -ELEMENTS[78116] = Fluid3D([16689,16702,16457,17153],0); -ELEMENTS[78117] = Fluid3D([10752,10556,11975,11059],0); -ELEMENTS[78118] = Fluid3D([3819,3245,3639,3720],0); -ELEMENTS[78119] = Fluid3D([13422,12583,12501,13483],0); -ELEMENTS[78120] = Fluid3D([6421,6162,5801,6824],0); -ELEMENTS[78121] = Fluid3D([11444,11868,12466,11310],0); -ELEMENTS[78122] = Fluid3D([8291,7392,7712,7629],0); -ELEMENTS[78123] = Fluid3D([11269,11589,12170,12487],0); -ELEMENTS[78124] = Fluid3D([11896,10727,11676,11927],0); -ELEMENTS[78125] = Fluid3D([6209,6961,6304,6017],0); -ELEMENTS[78126] = Fluid3D([2171,2010,2200,2061],0); -ELEMENTS[78127] = Fluid3D([1985,2038,2019,2250],0); -ELEMENTS[78128] = Fluid3D([1671,1803,1746,1618],0); -ELEMENTS[78129] = Fluid3D([2106,2219,2043,2144],0); -ELEMENTS[78130] = Fluid3D([5650,5841,5153,5043],0); -ELEMENTS[78131] = Fluid3D([17587,17943,17540,17677],0); -ELEMENTS[78132] = Fluid3D([4377,4315,4759,4186],0); -ELEMENTS[78133] = Fluid3D([13116,13138,13715,14124],0); -ELEMENTS[78134] = Fluid3D([17444,17004,17173,17691],0); -ELEMENTS[78135] = Fluid3D([14838,14522,14267,13615],0); -ELEMENTS[78136] = Fluid3D([6082,6711,5769,6251],0); -ELEMENTS[78137] = Fluid3D([5386,5008,5857,5316],0); -ELEMENTS[78138] = Fluid3D([3867,3620,3693,3370],0); -ELEMENTS[78139] = Fluid3D([3933,3554,4118,4295],0); -ELEMENTS[78140] = Fluid3D([15121,15757,15954,15438],0); -ELEMENTS[78141] = Fluid3D([12960,13419,13309,14148],0); -ELEMENTS[78142] = Fluid3D([18236,18179,18367,18133],0); -ELEMENTS[78143] = Fluid3D([12476,12114,11739,12955],0); -ELEMENTS[78144] = Fluid3D([8595,9240,7955,8996],0); -ELEMENTS[78145] = Fluid3D([3191,2941,3386,2806],0); -ELEMENTS[78146] = Fluid3D([17334,17033,17290,17742],0); -ELEMENTS[78147] = Fluid3D([4606,4048,4946,4413],0); -ELEMENTS[78148] = Fluid3D([5625,5834,5863,6682],0); -ELEMENTS[78149] = Fluid3D([16240,16535,15986,16704],0); -ELEMENTS[78150] = Fluid3D([15629,15291,14760,15594],0); -ELEMENTS[78151] = Fluid3D([13314,12832,12324,12664],0); -ELEMENTS[78152] = Fluid3D([12324,13314,12664,13231],0); -ELEMENTS[78153] = Fluid3D([5392,5112,4816,4542],0); -ELEMENTS[78154] = Fluid3D([4796,5149,4804,4284],0); -ELEMENTS[78155] = Fluid3D([8720,8636,9612,10006],0); -ELEMENTS[78156] = Fluid3D([16659,17180,16672,17164],0); -ELEMENTS[78157] = Fluid3D([4309,4704,4886,4487],0); -ELEMENTS[78158] = Fluid3D([7300,7167,7616,8429],0); -ELEMENTS[78159] = Fluid3D([5598,5760,5670,5084],0); -ELEMENTS[78160] = Fluid3D([11392,10561,11203,11799],0); -ELEMENTS[78161] = Fluid3D([16345,16473,17039,16800],0); -ELEMENTS[78162] = Fluid3D([12936,12851,13977,14197],0); -ELEMENTS[78163] = Fluid3D([15144,14599,14375,14520],0); -ELEMENTS[78164] = Fluid3D([4620,4840,4132,3957],0); -ELEMENTS[78165] = Fluid3D([13679,13299,12887,12901],0); -ELEMENTS[78166] = Fluid3D([6711,6082,6368,6251],0); -ELEMENTS[78167] = Fluid3D([8379,8882,9208,9285],0); -ELEMENTS[78168] = Fluid3D([12841,12368,12599,11930],0); -ELEMENTS[78169] = Fluid3D([12432,12831,12444,13310],0); -ELEMENTS[78170] = Fluid3D([13796,13459,14295,13127],0); -ELEMENTS[78171] = Fluid3D([4251,4033,3809,4307],0); -ELEMENTS[78172] = Fluid3D([18628,18643,18520,18518],0); -ELEMENTS[78173] = Fluid3D([15365,15180,16165,15967],0); -ELEMENTS[78174] = Fluid3D([3245,3168,2819,3158],0); -ELEMENTS[78175] = Fluid3D([16300,15940,15480,15297],0); -ELEMENTS[78176] = Fluid3D([1795,1811,2009,1809],0); -ELEMENTS[78177] = Fluid3D([17313,17057,16719,16987],0); -ELEMENTS[78178] = Fluid3D([16719,17313,16987,17293],0); -ELEMENTS[78179] = Fluid3D([7661,7733,6479,6988],0); -ELEMENTS[78180] = Fluid3D([4230,3894,3490,3814],0); -ELEMENTS[78181] = Fluid3D([5750,6645,6134,6013],0); -ELEMENTS[78182] = Fluid3D([17051,17154,16619,16514],0); -ELEMENTS[78183] = Fluid3D([5944,6466,6042,6109],0); -ELEMENTS[78184] = Fluid3D([17658,17853,17378,17834],0); -ELEMENTS[78185] = Fluid3D([17658,17853,17834,18066],0); -ELEMENTS[78186] = Fluid3D([7572,6868,6862,6984],0); -ELEMENTS[78187] = Fluid3D([11994,11763,10893,11993],0); -ELEMENTS[78188] = Fluid3D([15841,15616,15145,14811],0); -ELEMENTS[78189] = Fluid3D([17351,17314,17757,17274],0); -ELEMENTS[78190] = Fluid3D([13475,13403,12448,12301],0); -ELEMENTS[78191] = Fluid3D([5645,5676,5322,5884],0); -ELEMENTS[78192] = Fluid3D([16327,16280,16024,16798],0); -ELEMENTS[78193] = Fluid3D([10789,10867,10520,9481],0); -ELEMENTS[78194] = Fluid3D([8075,7493,7360,7015],0); -ELEMENTS[78195] = Fluid3D([9756,10131,10232,9549],0); -ELEMENTS[78196] = Fluid3D([15503,15339,15664,16213],0); -ELEMENTS[78197] = Fluid3D([12627,12869,13282,13791],0); -ELEMENTS[78198] = Fluid3D([14514,13851,14674,14279],0); -ELEMENTS[78199] = Fluid3D([6038,5977,5282,5522],0); -ELEMENTS[78200] = Fluid3D([6038,5977,5522,5948],0); -ELEMENTS[78201] = Fluid3D([8788,8852,9616,10114],0); -ELEMENTS[78202] = Fluid3D([12492,12150,11855,13125],0); -ELEMENTS[78203] = Fluid3D([14831,14559,15134,15436],0); -ELEMENTS[78204] = Fluid3D([14831,14559,15436,14495],0); -ELEMENTS[78205] = Fluid3D([13470,13902,14166,14792],0); -ELEMENTS[78206] = Fluid3D([11269,12052,12170,10718],0); -ELEMENTS[78207] = Fluid3D([9707,10055,11188,10454],0); -ELEMENTS[78208] = Fluid3D([16327,16024,16601,16798],0); -ELEMENTS[78209] = Fluid3D([16601,16327,16798,16979],0); -ELEMENTS[78210] = Fluid3D([6503,7051,7623,6639],0); -ELEMENTS[78211] = Fluid3D([13311,12985,13410,12522],0); -ELEMENTS[78212] = Fluid3D([4105,4641,4459,3879],0); -ELEMENTS[78213] = Fluid3D([16704,16565,16288,15878],0); -ELEMENTS[78214] = Fluid3D([2214,2200,1932,2032],0); -ELEMENTS[78215] = Fluid3D([11163,11331,10498,11839],0); -ELEMENTS[78216] = Fluid3D([16464,16910,16164,16373],0); -ELEMENTS[78217] = Fluid3D([15931,16086,15306,15360],0); -ELEMENTS[78218] = Fluid3D([16086,15306,15360,15974],0); -ELEMENTS[78219] = Fluid3D([4014,4135,3680,3546],0); -ELEMENTS[78220] = Fluid3D([11708,11699,10920,11622],0); -ELEMENTS[78221] = Fluid3D([3164,3236,3002,2692],0); -ELEMENTS[78222] = Fluid3D([14182,13669,14561,14741],0); -ELEMENTS[78223] = Fluid3D([9244,8288,8735,9201],0); -ELEMENTS[78224] = Fluid3D([3905,4135,4053,3546],0); -ELEMENTS[78225] = Fluid3D([9613,10254,10207,11103],0); -ELEMENTS[78226] = Fluid3D([15927,16294,16858,16500],0); -ELEMENTS[78227] = Fluid3D([16947,16591,17160,17264],0); -ELEMENTS[78228] = Fluid3D([14851,15126,15277,15897],0); -ELEMENTS[78229] = Fluid3D([7299,7585,7395,6646],0); -ELEMENTS[78230] = Fluid3D([2037,2009,1915,1809],0); -ELEMENTS[78231] = Fluid3D([4997,5315,5742,5099],0); -ELEMENTS[78232] = Fluid3D([7135,6278,5995,6772],0); -ELEMENTS[78233] = Fluid3D([17888,17871,17514,17770],0); -ELEMENTS[78234] = Fluid3D([15420,15097,15353,14555],0); -ELEMENTS[78235] = Fluid3D([4010,4231,4069,4755],0); -ELEMENTS[78236] = Fluid3D([7690,6696,6709,7355],0); -ELEMENTS[78237] = Fluid3D([8350,7475,8166,8333],0); -ELEMENTS[78238] = Fluid3D([17943,17587,17875,17731],0); -ELEMENTS[78239] = Fluid3D([6181,6284,5754,5449],0); -ELEMENTS[78240] = Fluid3D([16663,16266,16439,15718],0); -ELEMENTS[78241] = Fluid3D([3157,2750,2963,2859],0); -ELEMENTS[78242] = Fluid3D([15509,16174,15749,16188],0); -ELEMENTS[78243] = Fluid3D([10293,10855,11171,9723],0); -ELEMENTS[78244] = Fluid3D([12254,12967,12732,13649],0); -ELEMENTS[78245] = Fluid3D([17290,17480,17742,17033],0); -ELEMENTS[78246] = Fluid3D([16358,16257,16602,17055],0); -ELEMENTS[78247] = Fluid3D([14520,14122,14599,14375],0); -ELEMENTS[78248] = Fluid3D([16528,16123,16461,16968],0); -ELEMENTS[78249] = Fluid3D([10624,11411,10811,9853],0); -ELEMENTS[78250] = Fluid3D([9854,10209,9500,8595],0); -ELEMENTS[78251] = Fluid3D([15216,15651,14641,15403],0); -ELEMENTS[78252] = Fluid3D([12527,13277,13173,13023],0); -ELEMENTS[78253] = Fluid3D([5674,5090,5335,4731],0); -ELEMENTS[78254] = Fluid3D([8745,8919,9962,9217],0); -ELEMENTS[78255] = Fluid3D([16555,16299,16997,16663],0); -ELEMENTS[78256] = Fluid3D([16110,16063,16821,16765],0); -ELEMENTS[78257] = Fluid3D([8710,8860,8758,9812],0); -ELEMENTS[78258] = Fluid3D([18327,18201,18461,18455],0); -ELEMENTS[78259] = Fluid3D([2955,2931,3065,3458],0); -ELEMENTS[78260] = Fluid3D([5566,6520,5824,6069],0); -ELEMENTS[78261] = Fluid3D([13352,13606,14449,14021],0); -ELEMENTS[78262] = Fluid3D([8385,9108,8979,8347],0); -ELEMENTS[78263] = Fluid3D([2494,2373,2229,2300],0); -ELEMENTS[78264] = Fluid3D([2272,2532,2598,2910],0); -ELEMENTS[78265] = Fluid3D([9781,9068,8552,8566],0); -ELEMENTS[78266] = Fluid3D([9630,10369,10800,10160],0); -ELEMENTS[78267] = Fluid3D([8270,8655,7478,7367],0); -ELEMENTS[78268] = Fluid3D([18535,18520,18628,18638],0); -ELEMENTS[78269] = Fluid3D([13571,14308,14893,14300],0); -ELEMENTS[78270] = Fluid3D([14598,15022,15535,15414],0); -ELEMENTS[78271] = Fluid3D([8627,8847,9247,8543],0); -ELEMENTS[78272] = Fluid3D([4014,4135,3546,3596],0); -ELEMENTS[78273] = Fluid3D([9962,10142,10928,11164],0); -ELEMENTS[78274] = Fluid3D([9688,8819,8353,9109],0); -ELEMENTS[78275] = Fluid3D([6386,6911,7461,7757],0); -ELEMENTS[78276] = Fluid3D([14813,14329,13859,14304],0); -ELEMENTS[78277] = Fluid3D([13138,14124,13780,13715],0); -ELEMENTS[78278] = Fluid3D([10980,11054,9949,9728],0); -ELEMENTS[78279] = Fluid3D([9242,9365,8741,7969],0); -ELEMENTS[78280] = Fluid3D([12273,12732,12950,13334],0); -ELEMENTS[78281] = Fluid3D([16691,16214,16873,16842],0); -ELEMENTS[78282] = Fluid3D([17941,17735,17681,17461],0); -ELEMENTS[78283] = Fluid3D([14449,14074,13352,13057],0); -ELEMENTS[78284] = Fluid3D([9062,8786,7545,8124],0); -ELEMENTS[78285] = Fluid3D([9062,8786,8124,9286],0); -ELEMENTS[78286] = Fluid3D([17094,17339,17723,17639],0); -ELEMENTS[78287] = Fluid3D([16139,16086,15360,15974],0); -ELEMENTS[78288] = Fluid3D([3433,3164,3002,2878],0); -ELEMENTS[78289] = Fluid3D([16939,16586,16132,16453],0); -ELEMENTS[78290] = Fluid3D([16373,16366,16464,16910],0); -ELEMENTS[78291] = Fluid3D([14888,14339,14072,13642],0); -ELEMENTS[78292] = Fluid3D([2664,2772,3077,2718],0); -ELEMENTS[78293] = Fluid3D([10343,10016,11483,10993],0); -ELEMENTS[78294] = Fluid3D([3381,3692,3181,3646],0); -ELEMENTS[78295] = Fluid3D([15521,15777,14941,15441],0); -ELEMENTS[78296] = Fluid3D([12226,12538,11823,11336],0); -ELEMENTS[78297] = Fluid3D([16441,16925,16579,16405],0); -ELEMENTS[78298] = Fluid3D([3420,3351,3873,3659],0); -ELEMENTS[78299] = Fluid3D([8439,7662,7454,7538],0); -ELEMENTS[78300] = Fluid3D([15827,16073,15801,15921],0); -ELEMENTS[78301] = Fluid3D([4131,4498,4015,4871],0); -ELEMENTS[78302] = Fluid3D([9824,9628,10414,8875],0); -ELEMENTS[78303] = Fluid3D([10447,10850,10181,11280],0); -ELEMENTS[78304] = Fluid3D([15330,15460,15052,14427],0); -ELEMENTS[78305] = Fluid3D([2697,2504,2771,2792],0); -ELEMENTS[78306] = Fluid3D([18005,17834,18256,18066],0); -ELEMENTS[78307] = Fluid3D([13337,14147,13879,13633],0); -ELEMENTS[78308] = Fluid3D([9848,9217,8895,8745],0); -ELEMENTS[78309] = Fluid3D([4542,3866,4521,3805],0); -ELEMENTS[78310] = Fluid3D([4583,4774,4037,4241],0); -ELEMENTS[78311] = Fluid3D([3717,4035,4318,4267],0); -ELEMENTS[78312] = Fluid3D([17904,18098,17731,18024],0); -ELEMENTS[78313] = Fluid3D([5093,5626,5713,5897],0); -ELEMENTS[78314] = Fluid3D([15468,14843,15820,15659],0); -ELEMENTS[78315] = Fluid3D([2905,2943,2512,2555],0); -ELEMENTS[78316] = Fluid3D([3157,3187,3285,2859],0); -ELEMENTS[78317] = Fluid3D([13282,12627,13791,13660],0); -ELEMENTS[78318] = Fluid3D([15297,15480,15025,15940],0); -ELEMENTS[78319] = Fluid3D([6566,7364,7082,6721],0); -ELEMENTS[78320] = Fluid3D([3214,3066,2888,2813],0); -ELEMENTS[78321] = Fluid3D([7454,8439,7538,8372],0); -ELEMENTS[78322] = Fluid3D([16829,17276,16784,16593],0); -ELEMENTS[78323] = Fluid3D([14816,14696,14085,15489],0); -ELEMENTS[78324] = Fluid3D([5372,5136,4617,4837],0); -ELEMENTS[78325] = Fluid3D([12777,13610,13718,13349],0); -ELEMENTS[78326] = Fluid3D([15800,14874,15320,15546],0); -ELEMENTS[78327] = Fluid3D([12936,12823,12165,13165],0); -ELEMENTS[78328] = Fluid3D([3612,4267,3717,4318],0); -ELEMENTS[78329] = Fluid3D([7501,6543,6892,6949],0); -ELEMENTS[78330] = Fluid3D([7501,6543,6949,7213],0); -ELEMENTS[78331] = Fluid3D([17752,18097,18088,17650],0); -ELEMENTS[78332] = Fluid3D([2812,3015,3314,3061],0); -ELEMENTS[78333] = Fluid3D([10232,11073,9549,10131],0); -ELEMENTS[78334] = Fluid3D([4225,3881,3563,3838],0); -ELEMENTS[78335] = Fluid3D([18580,18566,18527,18426],0); -ELEMENTS[78336] = Fluid3D([2605,2813,2888,3066],0); -ELEMENTS[78337] = Fluid3D([9131,9289,9286,8124],0); -ELEMENTS[78338] = Fluid3D([16930,16463,16803,17212],0); -ELEMENTS[78339] = Fluid3D([17164,17056,16780,17282],0); -ELEMENTS[78340] = Fluid3D([6853,6466,6109,6042],0); -ELEMENTS[78341] = Fluid3D([13402,12444,13525,12831],0); -ELEMENTS[78342] = Fluid3D([15596,15638,16038,15474],0); -ELEMENTS[78343] = Fluid3D([15916,15921,15801,16362],0); -ELEMENTS[78344] = Fluid3D([7914,8781,7831,9051],0); -ELEMENTS[78345] = Fluid3D([7861,8753,8920,9230],0); -ELEMENTS[78346] = Fluid3D([13711,14532,13807,13429],0); -ELEMENTS[78347] = Fluid3D([16669,16456,15999,16753],0); -ELEMENTS[78348] = Fluid3D([4794,5535,5195,5099],0); -ELEMENTS[78349] = Fluid3D([16160,16071,16762,16799],0); -ELEMENTS[78350] = Fluid3D([13972,14086,14637,13957],0); -ELEMENTS[78351] = Fluid3D([17613,17456,17373,17291],0); -ELEMENTS[78352] = Fluid3D([16834,16246,16340,16513],0); -ELEMENTS[78353] = Fluid3D([16025,16317,16131,15357],0); -ELEMENTS[78354] = Fluid3D([18175,17863,18149,17946],0); -ELEMENTS[78355] = Fluid3D([3124,3246,2714,2914],0); -ELEMENTS[78356] = Fluid3D([15904,15494,15762,15214],0); -ELEMENTS[78357] = Fluid3D([3818,3593,3919,3527],0); -ELEMENTS[78358] = Fluid3D([14449,14833,14021,13606],0); -ELEMENTS[78359] = Fluid3D([7785,7731,6614,6875],0); -ELEMENTS[78360] = Fluid3D([16394,16667,16125,15697],0); -ELEMENTS[78361] = Fluid3D([11039,10869,10581,11849],0); -ELEMENTS[78362] = Fluid3D([12622,12116,11551,12910],0); -ELEMENTS[78363] = Fluid3D([18647,18660,18574,18657],0); -ELEMENTS[78364] = Fluid3D([17993,18222,18099,18324],0); -ELEMENTS[78365] = Fluid3D([14324,14444,14330,13744],0); -ELEMENTS[78366] = Fluid3D([16340,16977,16834,16513],0); -ELEMENTS[78367] = Fluid3D([15798,15191,15995,16220],0); -ELEMENTS[78368] = Fluid3D([2137,2241,2453,2535],0); -ELEMENTS[78369] = Fluid3D([12967,13138,13918,13649],0); -ELEMENTS[78370] = Fluid3D([8204,7363,7969,7396],0); -ELEMENTS[78371] = Fluid3D([16693,16301,16601,16993],0); -ELEMENTS[78372] = Fluid3D([4459,4105,3879,4449],0); -ELEMENTS[78373] = Fluid3D([3376,3084,3331,3530],0); -ELEMENTS[78374] = Fluid3D([14351,14858,13566,13754],0); -ELEMENTS[78375] = Fluid3D([14351,14858,13754,14460],0); -ELEMENTS[78376] = Fluid3D([11567,10472,11489,11429],0); -ELEMENTS[78377] = Fluid3D([13704,12979,13876,14373],0); -ELEMENTS[78378] = Fluid3D([16249,15890,15826,15384],0); -ELEMENTS[78379] = Fluid3D([4897,4442,4754,5334],0); -ELEMENTS[78380] = Fluid3D([10637,11768,11861,11698],0); -ELEMENTS[78381] = Fluid3D([15732,15535,15065,15046],0); -ELEMENTS[78382] = Fluid3D([2692,2806,2863,3236],0); -ELEMENTS[78383] = Fluid3D([3890,4446,3760,4521],0); -ELEMENTS[78384] = Fluid3D([18589,18536,18470,18374],0); -ELEMENTS[78385] = Fluid3D([8720,9954,10006,9612],0); -ELEMENTS[78386] = Fluid3D([6901,8090,7517,6899],0); -ELEMENTS[78387] = Fluid3D([7167,7300,7634,7937],0); -ELEMENTS[78388] = Fluid3D([7167,7300,7937,8429],0); -ELEMENTS[78389] = Fluid3D([7300,7937,8429,7616],0); -ELEMENTS[78390] = Fluid3D([15509,15749,15648,16188],0); -ELEMENTS[78391] = Fluid3D([16425,16897,16865,16967],0); -ELEMENTS[78392] = Fluid3D([12684,11995,12164,11632],0); -ELEMENTS[78393] = Fluid3D([12164,12684,11632,13003],0); -ELEMENTS[78394] = Fluid3D([12445,12293,11795,12903],0); -ELEMENTS[78395] = Fluid3D([16576,16504,17136,16836],0); -ELEMENTS[78396] = Fluid3D([6918,6711,6368,7147],0); -ELEMENTS[78397] = Fluid3D([15585,15205,14495,15378],0); -ELEMENTS[78398] = Fluid3D([15585,15205,15378,15815],0); -ELEMENTS[78399] = Fluid3D([16495,15920,15795,16076],0); -ELEMENTS[78400] = Fluid3D([11964,11385,10424,11217],0); -ELEMENTS[78401] = Fluid3D([16389,16303,17072,16948],0); -ELEMENTS[78402] = Fluid3D([16306,15503,15749,16213],0); -ELEMENTS[78403] = Fluid3D([15986,16013,16240,16704],0); -ELEMENTS[78404] = Fluid3D([5694,5719,5985,6689],0); -ELEMENTS[78405] = Fluid3D([13352,13057,14021,14449],0); -ELEMENTS[78406] = Fluid3D([3708,4015,3561,3306],0); -ELEMENTS[78407] = Fluid3D([18451,18332,18241,18441],0); -ELEMENTS[78408] = Fluid3D([14767,15618,14662,14991],0); -ELEMENTS[78409] = Fluid3D([13085,12538,12891,11823],0); -ELEMENTS[78410] = Fluid3D([12299,11797,13299,12887],0); -ELEMENTS[78411] = Fluid3D([18510,18276,18363,18287],0); -ELEMENTS[78412] = Fluid3D([3289,3813,3908,3692],0); -ELEMENTS[78413] = Fluid3D([15205,15585,16007,15815],0); -ELEMENTS[78414] = Fluid3D([8819,9688,9850,9109],0); -ELEMENTS[78415] = Fluid3D([13127,12764,14295,13796],0); -ELEMENTS[78416] = Fluid3D([17173,17505,17066,17589],0); -ELEMENTS[78417] = Fluid3D([3187,3590,3829,3560],0); -ELEMENTS[78418] = Fluid3D([18391,18380,18503,18498],0); -ELEMENTS[78419] = Fluid3D([18391,18380,18498,18418],0); -ELEMENTS[78420] = Fluid3D([7167,7634,8161,7937],0); -ELEMENTS[78421] = Fluid3D([18657,18641,18574,18647],0); -ELEMENTS[78422] = Fluid3D([15188,15828,15674,15852],0); -ELEMENTS[78423] = Fluid3D([16795,17084,17077,17525],0); -ELEMENTS[78424] = Fluid3D([17050,16666,17117,17219],0); -ELEMENTS[78425] = Fluid3D([15934,15546,15800,15320],0); -ELEMENTS[78426] = Fluid3D([14802,14938,14960,13842],0); -ELEMENTS[78427] = Fluid3D([18346,18309,18367,18476],0); -ELEMENTS[78428] = Fluid3D([8487,9131,7595,8124],0); -ELEMENTS[78429] = Fluid3D([17920,17739,18027,18073],0); -ELEMENTS[78430] = Fluid3D([10776,11367,9899,9896],0); -ELEMENTS[78431] = Fluid3D([18647,18565,18641,18574],0); -ELEMENTS[78432] = Fluid3D([14674,14279,15233,14514],0); -ELEMENTS[78433] = Fluid3D([11931,11286,12405,12690],0); -ELEMENTS[78434] = Fluid3D([4506,3913,4286,4101],0); -ELEMENTS[78435] = Fluid3D([2806,2816,2863,3236],0); -ELEMENTS[78436] = Fluid3D([3490,3814,3746,4230],0); -ELEMENTS[78437] = Fluid3D([8125,8429,7616,7167],0); -ELEMENTS[78438] = Fluid3D([7581,8302,7082,8524],0); -ELEMENTS[78439] = Fluid3D([2648,3053,2775,2542],0); -ELEMENTS[78440] = Fluid3D([12777,12481,13610,13349],0); -ELEMENTS[78441] = Fluid3D([6601,5848,6090,6193],0); -ELEMENTS[78442] = Fluid3D([13366,13989,13775,14516],0); -ELEMENTS[78443] = Fluid3D([2664,2683,3077,3198],0); -ELEMENTS[78444] = Fluid3D([7493,7914,6875,7731],0); -ELEMENTS[78445] = Fluid3D([9148,9257,10390,10414],0); -ELEMENTS[78446] = Fluid3D([9257,10390,10414,10587],0); -ELEMENTS[78447] = Fluid3D([10503,11163,10498,10470],0); -ELEMENTS[78448] = Fluid3D([11163,10498,10470,11839],0); -ELEMENTS[78449] = Fluid3D([14649,13986,14476,14586],0); -ELEMENTS[78450] = Fluid3D([1942,2056,1875,2007],0); -ELEMENTS[78451] = Fluid3D([7937,7167,8429,8161],0); -ELEMENTS[78452] = Fluid3D([13466,12964,12664,12038],0); -ELEMENTS[78453] = Fluid3D([11365,11405,9917,10270],0); -ELEMENTS[78454] = Fluid3D([7669,7881,7127,6680],0); -ELEMENTS[78455] = Fluid3D([15770,15386,15677,15502],0); -ELEMENTS[78456] = Fluid3D([15916,15284,15939,16362],0); -ELEMENTS[78457] = Fluid3D([17313,17057,16987,17272],0); -ELEMENTS[78458] = Fluid3D([2650,2962,2710,3159],0); -ELEMENTS[78459] = Fluid3D([2816,2806,3191,3236],0); -ELEMENTS[78460] = Fluid3D([6087,5476,5914,6044],0); -ELEMENTS[78461] = Fluid3D([17066,17041,17348,17589],0); -ELEMENTS[78462] = Fluid3D([10316,10659,9216,9589],0); -ELEMENTS[78463] = Fluid3D([13739,13736,12754,12703],0); -ELEMENTS[78464] = Fluid3D([3236,3180,3191,2816],0); -ELEMENTS[78465] = Fluid3D([3672,3546,3334,3905],0); -ELEMENTS[78466] = Fluid3D([18499,18346,18367,18476],0); -ELEMENTS[78467] = Fluid3D([4743,4506,4101,4141],0); -ELEMENTS[78468] = Fluid3D([3783,3118,3646,3381],0); -ELEMENTS[78469] = Fluid3D([10626,10718,12170,12052],0); -ELEMENTS[78470] = Fluid3D([11448,9956,10552,11105],0); -ELEMENTS[78471] = Fluid3D([14021,14833,14374,13606],0); -ELEMENTS[78472] = Fluid3D([10181,9936,9697,8452],0); -ELEMENTS[78473] = Fluid3D([13610,13565,13349,12481],0); -ELEMENTS[78474] = Fluid3D([11537,11365,11839,10470],0); -ELEMENTS[78475] = Fluid3D([7871,7657,7471,7678],0); -ELEMENTS[78476] = Fluid3D([17028,17301,16806,16897],0); -ELEMENTS[78477] = Fluid3D([15486,14877,15502,15677],0); -ELEMENTS[78478] = Fluid3D([15921,16200,16525,16362],0); -ELEMENTS[78479] = Fluid3D([2116,2075,2250,1989],0); -ELEMENTS[78480] = Fluid3D([3693,3620,3061,3370],0); -ELEMENTS[78481] = Fluid3D([18380,18451,18503,18498],0); -ELEMENTS[78482] = Fluid3D([14834,15052,14427,15330],0); -ELEMENTS[78483] = Fluid3D([8132,7692,8820,7629],0); -ELEMENTS[78484] = Fluid3D([16366,16464,16910,17106],0); -ELEMENTS[78485] = Fluid3D([3746,4389,4230,3814],0); -ELEMENTS[78486] = Fluid3D([12901,12299,13299,12887],0); -ELEMENTS[78487] = Fluid3D([8597,7969,8204,9365],0); -ELEMENTS[78488] = Fluid3D([7831,7731,6875,7914],0); -ELEMENTS[78489] = Fluid3D([15801,15284,15916,16362],0); -ELEMENTS[78490] = Fluid3D([9692,10188,10626,9161],0); -ELEMENTS[78491] = Fluid3D([16945,17060,17373,17291],0); -ELEMENTS[78492] = Fluid3D([3314,3061,2628,2812],0); -ELEMENTS[78493] = Fluid3D([7731,7831,9051,7914],0); diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.geo b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.geo deleted file mode 100644 index cb1bb7e5afb6..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.geo and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.init b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.init deleted file mode 100644 index 0f96cfc54c1b..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.init +++ /dev/null @@ -1,21754 +0,0 @@ -// Fixing degrees of freedom in nodes - -NODES[1](IS_STRUCTURE,0) = 1.000000; -NODES[2](IS_STRUCTURE,0) = 1.000000; -NODES[3](IS_STRUCTURE,0) = 1.000000; -NODES[4](IS_STRUCTURE,0) = 1.000000; -NODES[5](IS_STRUCTURE,0) = 1.000000; -NODES[6](IS_STRUCTURE,0) = 1.000000; -NODES[7](IS_STRUCTURE,0) = 1.000000; -NODES[8](IS_STRUCTURE,0) = 1.000000; -NODES[9](IS_STRUCTURE,0) = 1.000000; -NODES[10](IS_STRUCTURE,0) = 1.000000; -NODES[11](IS_STRUCTURE,0) = 1.000000; -NODES[12](IS_STRUCTURE,0) = 1.000000; -NODES[13](IS_STRUCTURE,0) = 1.000000; -NODES[14](IS_STRUCTURE,0) = 1.000000; -NODES[15](IS_STRUCTURE,0) = 1.000000; -NODES[16](IS_STRUCTURE,0) = 1.000000; -NODES[17](IS_STRUCTURE,0) = 1.000000; -NODES[18](IS_STRUCTURE,0) = 1.000000; -NODES[19](IS_STRUCTURE,0) = 1.000000; -NODES[20](IS_STRUCTURE,0) = 1.000000; -NODES[21](IS_STRUCTURE,0) = 1.000000; -NODES[22](IS_STRUCTURE,0) = 1.000000; -NODES[23](IS_STRUCTURE,0) = 1.000000; -NODES[24](IS_STRUCTURE,0) = 1.000000; -NODES[25](IS_STRUCTURE,0) = 1.000000; -NODES[26](IS_STRUCTURE,0) = 1.000000; -NODES[27](IS_STRUCTURE,0) = 1.000000; -NODES[28](IS_STRUCTURE,0) = 1.000000; -NODES[29](IS_STRUCTURE,0) = 1.000000; -NODES[30](IS_STRUCTURE,0) = 1.000000; -NODES[31](IS_STRUCTURE,0) = 1.000000; -NODES[32](IS_STRUCTURE,0) = 1.000000; -NODES[33](IS_STRUCTURE,0) = 1.000000; -NODES[34](IS_STRUCTURE,0) = 1.000000; -NODES[35](IS_STRUCTURE,0) = 1.000000; -NODES[36](IS_STRUCTURE,0) = 1.000000; -NODES[37](IS_STRUCTURE,0) = 1.000000; -NODES[38](IS_STRUCTURE,0) = 1.000000; -NODES[39](IS_STRUCTURE,0) = 1.000000; -NODES[40](IS_STRUCTURE,0) = 1.000000; -NODES[41](IS_STRUCTURE,0) = 1.000000; -NODES[42](IS_STRUCTURE,0) = 1.000000; -NODES[43](IS_STRUCTURE,0) = 1.000000; -NODES[44](IS_STRUCTURE,0) = 1.000000; -NODES[45](IS_STRUCTURE,0) = 1.000000; -NODES[46](IS_STRUCTURE,0) = 1.000000; -NODES[47](IS_STRUCTURE,0) = 1.000000; -NODES[48](IS_STRUCTURE,0) = 1.000000; -NODES[49](IS_STRUCTURE,0) = 1.000000; -NODES[50](IS_STRUCTURE,0) = 1.000000; -NODES[51](IS_STRUCTURE,0) = 1.000000; -NODES[52](IS_STRUCTURE,0) = 1.000000; -NODES[53](IS_STRUCTURE,0) = 1.000000; -NODES[54](IS_STRUCTURE,0) = 1.000000; -NODES[55](IS_STRUCTURE,0) = 1.000000; -NODES[56](IS_STRUCTURE,0) = 1.000000; -NODES[57](IS_STRUCTURE,0) = 1.000000; -NODES[58](IS_STRUCTURE,0) = 1.000000; -NODES[59](IS_STRUCTURE,0) = 1.000000; -NODES[60](IS_STRUCTURE,0) = 1.000000; -NODES[61](IS_STRUCTURE,0) = 1.000000; -NODES[62](IS_STRUCTURE,0) = 1.000000; -NODES[63](IS_STRUCTURE,0) = 1.000000; -NODES[64](IS_STRUCTURE,0) = 1.000000; -NODES[65](IS_STRUCTURE,0) = 1.000000; -NODES[66](IS_STRUCTURE,0) = 1.000000; -NODES[67](IS_STRUCTURE,0) = 1.000000; -NODES[68](IS_STRUCTURE,0) = 1.000000; -NODES[69](IS_STRUCTURE,0) = 1.000000; -NODES[70](IS_STRUCTURE,0) = 1.000000; -NODES[71](IS_STRUCTURE,0) = 1.000000; -NODES[72](IS_STRUCTURE,0) = 1.000000; -NODES[73](IS_STRUCTURE,0) = 1.000000; -NODES[74](IS_STRUCTURE,0) = 1.000000; -NODES[75](IS_STRUCTURE,0) = 1.000000; -NODES[76](IS_STRUCTURE,0) = 1.000000; -NODES[77](IS_STRUCTURE,0) = 1.000000; -NODES[78](IS_STRUCTURE,0) = 1.000000; -NODES[79](IS_STRUCTURE,0) = 1.000000; -NODES[80](IS_STRUCTURE,0) = 1.000000; -NODES[81](IS_STRUCTURE,0) = 1.000000; -NODES[82](IS_STRUCTURE,0) = 1.000000; -NODES[83](IS_STRUCTURE,0) = 1.000000; -NODES[84](IS_STRUCTURE,0) = 1.000000; -NODES[85](IS_STRUCTURE,0) = 1.000000; -NODES[86](IS_STRUCTURE,0) = 1.000000; -NODES[87](IS_STRUCTURE,0) = 1.000000; -NODES[88](IS_STRUCTURE,0) = 1.000000; -NODES[89](IS_STRUCTURE,0) = 1.000000; -NODES[90](IS_STRUCTURE,0) = 1.000000; -NODES[91](IS_STRUCTURE,0) = 1.000000; -NODES[92](IS_STRUCTURE,0) = 1.000000; -NODES[93](IS_STRUCTURE,0) = 1.000000; -NODES[94](IS_STRUCTURE,0) = 1.000000; -NODES[95](IS_STRUCTURE,0) = 1.000000; -NODES[96](IS_STRUCTURE,0) = 1.000000; -NODES[97](IS_STRUCTURE,0) = 1.000000; -NODES[98](IS_STRUCTURE,0) = 1.000000; -NODES[99](IS_STRUCTURE,0) = 1.000000; -NODES[100](IS_STRUCTURE,0) = 1.000000; -NODES[101](IS_STRUCTURE,0) = 1.000000; -NODES[102](IS_STRUCTURE,0) = 1.000000; -NODES[103](IS_STRUCTURE,0) = 1.000000; -NODES[104](IS_STRUCTURE,0) = 1.000000; -NODES[105](IS_STRUCTURE,0) = 1.000000; -NODES[106](IS_STRUCTURE,0) = 1.000000; -NODES[107](IS_STRUCTURE,0) = 1.000000; -NODES[108](IS_STRUCTURE,0) = 1.000000; -NODES[109](IS_STRUCTURE,0) = 1.000000; -NODES[110](IS_STRUCTURE,0) = 1.000000; -NODES[111](IS_STRUCTURE,0) = 1.000000; -NODES[112](IS_STRUCTURE,0) = 1.000000; -NODES[113](IS_STRUCTURE,0) = 1.000000; -NODES[114](IS_STRUCTURE,0) = 1.000000; -NODES[115](IS_STRUCTURE,0) = 1.000000; -NODES[116](IS_STRUCTURE,0) = 1.000000; -NODES[117](IS_STRUCTURE,0) = 1.000000; -NODES[118](IS_STRUCTURE,0) = 1.000000; -NODES[119](IS_STRUCTURE,0) = 1.000000; -NODES[120](IS_STRUCTURE,0) = 1.000000; -NODES[121](IS_STRUCTURE,0) = 1.000000; -NODES[122](IS_STRUCTURE,0) = 1.000000; -NODES[123](IS_STRUCTURE,0) = 1.000000; -NODES[124](IS_STRUCTURE,0) = 1.000000; -NODES[125](IS_STRUCTURE,0) = 1.000000; -NODES[126](IS_STRUCTURE,0) = 1.000000; -NODES[127](IS_STRUCTURE,0) = 1.000000; -NODES[128](IS_STRUCTURE,0) = 1.000000; -NODES[129](IS_STRUCTURE,0) = 1.000000; -NODES[130](IS_STRUCTURE,0) = 1.000000; -NODES[131](IS_STRUCTURE,0) = 1.000000; -NODES[132](IS_STRUCTURE,0) = 1.000000; -NODES[133](IS_STRUCTURE,0) = 1.000000; -NODES[134](IS_STRUCTURE,0) = 1.000000; -NODES[135](IS_STRUCTURE,0) = 1.000000; -NODES[136](IS_STRUCTURE,0) = 1.000000; -NODES[137](IS_STRUCTURE,0) = 1.000000; -NODES[138](IS_STRUCTURE,0) = 1.000000; -NODES[139](IS_STRUCTURE,0) = 1.000000; -NODES[140](IS_STRUCTURE,0) = 1.000000; -NODES[141](IS_STRUCTURE,0) = 1.000000; -NODES[142](IS_STRUCTURE,0) = 1.000000; -NODES[143](IS_STRUCTURE,0) = 1.000000; -NODES[144](IS_STRUCTURE,0) = 1.000000; -NODES[145](IS_STRUCTURE,0) = 1.000000; -NODES[146](IS_STRUCTURE,0) = 1.000000; -NODES[147](IS_STRUCTURE,0) = 1.000000; -NODES[148](IS_STRUCTURE,0) = 1.000000; -NODES[149](IS_STRUCTURE,0) = 1.000000; -NODES[150](IS_STRUCTURE,0) = 1.000000; -NODES[151](IS_STRUCTURE,0) = 1.000000; -NODES[152](IS_STRUCTURE,0) = 1.000000; -NODES[153](IS_STRUCTURE,0) = 1.000000; -NODES[154](IS_STRUCTURE,0) = 1.000000; -NODES[155](IS_STRUCTURE,0) = 1.000000; -NODES[156](IS_STRUCTURE,0) = 1.000000; -NODES[157](IS_STRUCTURE,0) = 1.000000; -NODES[158](IS_STRUCTURE,0) = 1.000000; -NODES[159](IS_STRUCTURE,0) = 1.000000; -NODES[160](IS_STRUCTURE,0) = 1.000000; -NODES[161](IS_STRUCTURE,0) = 1.000000; -NODES[162](IS_STRUCTURE,0) = 1.000000; -NODES[163](IS_STRUCTURE,0) = 1.000000; -NODES[164](IS_STRUCTURE,0) = 1.000000; -NODES[165](IS_STRUCTURE,0) = 1.000000; -NODES[166](IS_STRUCTURE,0) = 1.000000; -NODES[167](IS_STRUCTURE,0) = 1.000000; -NODES[168](IS_STRUCTURE,0) = 1.000000; -NODES[169](IS_STRUCTURE,0) = 1.000000; -NODES[170](IS_STRUCTURE,0) = 1.000000; -NODES[171](IS_STRUCTURE,0) = 1.000000; -NODES[172](IS_STRUCTURE,0) = 1.000000; -NODES[173](IS_STRUCTURE,0) = 1.000000; -NODES[174](IS_STRUCTURE,0) = 1.000000; -NODES[175](IS_STRUCTURE,0) = 1.000000; -NODES[176](IS_STRUCTURE,0) = 1.000000; -NODES[177](IS_STRUCTURE,0) = 1.000000; -NODES[178](IS_STRUCTURE,0) = 1.000000; -NODES[179](IS_STRUCTURE,0) = 1.000000; -NODES[180](IS_STRUCTURE,0) = 1.000000; -NODES[181](IS_STRUCTURE,0) = 1.000000; -NODES[182](IS_STRUCTURE,0) = 1.000000; -NODES[183](IS_STRUCTURE,0) = 1.000000; -NODES[184](IS_STRUCTURE,0) = 1.000000; -NODES[185](IS_STRUCTURE,0) = 1.000000; -NODES[186](IS_STRUCTURE,0) = 1.000000; -NODES[187](IS_STRUCTURE,0) = 1.000000; -NODES[188](IS_STRUCTURE,0) = 1.000000; -NODES[189](IS_STRUCTURE,0) = 1.000000; -NODES[190](IS_STRUCTURE,0) = 1.000000; -NODES[191](IS_STRUCTURE,0) = 1.000000; -NODES[192](IS_STRUCTURE,0) = 1.000000; -NODES[193](IS_STRUCTURE,0) = 1.000000; -NODES[194](IS_STRUCTURE,0) = 1.000000; -NODES[195](IS_STRUCTURE,0) = 1.000000; -NODES[196](IS_STRUCTURE,0) = 1.000000; -NODES[197](IS_STRUCTURE,0) = 1.000000; -NODES[198](IS_STRUCTURE,0) = 1.000000; -NODES[199](IS_STRUCTURE,0) = 1.000000; -NODES[200](IS_STRUCTURE,0) = 1.000000; -NODES[201](IS_STRUCTURE,0) = 1.000000; -NODES[202](IS_STRUCTURE,0) = 1.000000; -NODES[203](IS_STRUCTURE,0) = 1.000000; -NODES[204](IS_STRUCTURE,0) = 1.000000; -NODES[205](IS_STRUCTURE,0) = 1.000000; -NODES[206](IS_STRUCTURE,0) = 1.000000; -NODES[207](IS_STRUCTURE,0) = 1.000000; -NODES[208](IS_STRUCTURE,0) = 1.000000; -NODES[209](IS_STRUCTURE,0) = 1.000000; -NODES[210](IS_STRUCTURE,0) = 1.000000; -NODES[211](IS_STRUCTURE,0) = 1.000000; -NODES[212](IS_STRUCTURE,0) = 1.000000; -NODES[213](IS_STRUCTURE,0) = 1.000000; -NODES[214](IS_STRUCTURE,0) = 1.000000; -NODES[215](IS_STRUCTURE,0) = 1.000000; -NODES[216](IS_STRUCTURE,0) = 1.000000; -NODES[217](IS_STRUCTURE,0) = 1.000000; -NODES[218](IS_STRUCTURE,0) = 1.000000; -NODES[219](IS_STRUCTURE,0) = 1.000000; -NODES[220](IS_STRUCTURE,0) = 1.000000; -NODES[221](IS_STRUCTURE,0) = 1.000000; -NODES[222](IS_STRUCTURE,0) = 1.000000; -NODES[223](IS_STRUCTURE,0) = 1.000000; -NODES[224](IS_STRUCTURE,0) = 1.000000; -NODES[225](IS_STRUCTURE,0) = 1.000000; -NODES[226](IS_STRUCTURE,0) = 1.000000; -NODES[227](IS_STRUCTURE,0) = 1.000000; -NODES[228](IS_STRUCTURE,0) = 1.000000; -NODES[229](IS_STRUCTURE,0) = 1.000000; -NODES[230](IS_STRUCTURE,0) = 1.000000; -NODES[231](IS_STRUCTURE,0) = 1.000000; -NODES[232](IS_STRUCTURE,0) = 1.000000; -NODES[233](IS_STRUCTURE,0) = 1.000000; -NODES[234](IS_STRUCTURE,0) = 1.000000; -NODES[235](IS_STRUCTURE,0) = 1.000000; -NODES[236](IS_STRUCTURE,0) = 1.000000; -NODES[237](IS_STRUCTURE,0) = 1.000000; -NODES[238](IS_STRUCTURE,0) = 1.000000; -NODES[239](IS_STRUCTURE,0) = 1.000000; -NODES[240](IS_STRUCTURE,0) = 1.000000; -NODES[241](IS_STRUCTURE,0) = 1.000000; -NODES[242](IS_STRUCTURE,0) = 1.000000; -NODES[243](IS_STRUCTURE,0) = 1.000000; -NODES[244](IS_STRUCTURE,0) = 1.000000; -NODES[245](IS_STRUCTURE,0) = 1.000000; -NODES[246](IS_STRUCTURE,0) = 1.000000; -NODES[247](IS_STRUCTURE,0) = 1.000000; -NODES[248](IS_STRUCTURE,0) = 1.000000; -NODES[249](IS_STRUCTURE,0) = 1.000000; -NODES[250](IS_STRUCTURE,0) = 1.000000; -NODES[251](IS_STRUCTURE,0) = 1.000000; -NODES[252](IS_STRUCTURE,0) = 1.000000; -NODES[253](IS_STRUCTURE,0) = 1.000000; -NODES[254](IS_STRUCTURE,0) = 1.000000; -NODES[255](IS_STRUCTURE,0) = 1.000000; -NODES[256](IS_STRUCTURE,0) = 1.000000; -NODES[257](IS_STRUCTURE,0) = 1.000000; -NODES[258](IS_STRUCTURE,0) = 1.000000; -NODES[259](IS_STRUCTURE,0) = 1.000000; -NODES[260](IS_STRUCTURE,0) = 1.000000; -NODES[261](IS_STRUCTURE,0) = 1.000000; -NODES[262](IS_STRUCTURE,0) = 1.000000; -NODES[263](IS_STRUCTURE,0) = 1.000000; -NODES[264](IS_STRUCTURE,0) = 1.000000; -NODES[265](IS_STRUCTURE,0) = 1.000000; -NODES[266](IS_STRUCTURE,0) = 1.000000; -NODES[267](IS_STRUCTURE,0) = 1.000000; -NODES[268](IS_STRUCTURE,0) = 1.000000; -NODES[269](IS_STRUCTURE,0) = 1.000000; -NODES[270](IS_STRUCTURE,0) = 1.000000; -NODES[271](IS_STRUCTURE,0) = 1.000000; -NODES[272](IS_STRUCTURE,0) = 1.000000; -NODES[273](IS_STRUCTURE,0) = 1.000000; -NODES[274](IS_STRUCTURE,0) = 1.000000; -NODES[275](IS_STRUCTURE,0) = 1.000000; -NODES[276](IS_STRUCTURE,0) = 1.000000; -NODES[277](IS_STRUCTURE,0) = 1.000000; -NODES[278](IS_STRUCTURE,0) = 1.000000; -NODES[279](IS_STRUCTURE,0) = 1.000000; -NODES[280](IS_STRUCTURE,0) = 1.000000; -NODES[281](IS_STRUCTURE,0) = 1.000000; -NODES[282](IS_STRUCTURE,0) = 1.000000; -NODES[283](IS_STRUCTURE,0) = 1.000000; -NODES[284](IS_STRUCTURE,0) = 1.000000; -NODES[285](IS_STRUCTURE,0) = 1.000000; -NODES[286](IS_STRUCTURE,0) = 1.000000; -NODES[287](IS_STRUCTURE,0) = 1.000000; -NODES[288](IS_STRUCTURE,0) = 1.000000; -NODES[289](IS_STRUCTURE,0) = 1.000000; -NODES[290](IS_STRUCTURE,0) = 1.000000; -NODES[291](IS_STRUCTURE,0) = 1.000000; -NODES[292](IS_STRUCTURE,0) = 1.000000; -NODES[293](IS_STRUCTURE,0) = 1.000000; -NODES[294](IS_STRUCTURE,0) = 1.000000; -NODES[295](IS_STRUCTURE,0) = 1.000000; -NODES[296](IS_STRUCTURE,0) = 1.000000; -NODES[297](IS_STRUCTURE,0) = 1.000000; -NODES[298](IS_STRUCTURE,0) = 1.000000; -NODES[299](IS_STRUCTURE,0) = 1.000000; -NODES[300](IS_STRUCTURE,0) = 1.000000; -NODES[301](IS_STRUCTURE,0) = 1.000000; -NODES[302](IS_STRUCTURE,0) = 1.000000; -NODES[303](IS_STRUCTURE,0) = 1.000000; -NODES[304](IS_STRUCTURE,0) = 1.000000; -NODES[305](IS_STRUCTURE,0) = 1.000000; -NODES[306](IS_STRUCTURE,0) = 1.000000; -NODES[307](IS_STRUCTURE,0) = 1.000000; -NODES[308](IS_STRUCTURE,0) = 1.000000; -NODES[309](IS_STRUCTURE,0) = 1.000000; -NODES[310](IS_STRUCTURE,0) = 1.000000; -NODES[311](IS_STRUCTURE,0) = 1.000000; -NODES[312](IS_STRUCTURE,0) = 1.000000; -NODES[313](IS_STRUCTURE,0) = 1.000000; -NODES[314](IS_STRUCTURE,0) = 1.000000; -NODES[315](IS_STRUCTURE,0) = 1.000000; -NODES[316](IS_STRUCTURE,0) = 1.000000; -NODES[317](IS_STRUCTURE,0) = 1.000000; -NODES[318](IS_STRUCTURE,0) = 1.000000; -NODES[319](IS_STRUCTURE,0) = 1.000000; -NODES[320](IS_STRUCTURE,0) = 1.000000; -NODES[321](IS_STRUCTURE,0) = 1.000000; -NODES[322](IS_STRUCTURE,0) = 1.000000; -NODES[323](IS_STRUCTURE,0) = 1.000000; -NODES[324](IS_STRUCTURE,0) = 1.000000; -NODES[325](IS_STRUCTURE,0) = 1.000000; -NODES[326](IS_STRUCTURE,0) = 1.000000; -NODES[327](IS_STRUCTURE,0) = 1.000000; -NODES[328](IS_STRUCTURE,0) = 1.000000; -NODES[329](IS_STRUCTURE,0) = 1.000000; -NODES[330](IS_STRUCTURE,0) = 1.000000; -NODES[331](IS_STRUCTURE,0) = 1.000000; -NODES[332](IS_STRUCTURE,0) = 1.000000; -NODES[333](IS_STRUCTURE,0) = 1.000000; -NODES[334](IS_STRUCTURE,0) = 1.000000; -NODES[335](IS_STRUCTURE,0) = 1.000000; -NODES[336](IS_STRUCTURE,0) = 1.000000; -NODES[337](IS_STRUCTURE,0) = 1.000000; -NODES[338](IS_STRUCTURE,0) = 1.000000; -NODES[339](IS_STRUCTURE,0) = 1.000000; -NODES[340](IS_STRUCTURE,0) = 1.000000; -NODES[341](IS_STRUCTURE,0) = 1.000000; -NODES[342](IS_STRUCTURE,0) = 1.000000; -NODES[343](IS_STRUCTURE,0) = 1.000000; -NODES[344](IS_STRUCTURE,0) = 1.000000; -NODES[345](IS_STRUCTURE,0) = 1.000000; -NODES[346](IS_STRUCTURE,0) = 1.000000; -NODES[347](IS_STRUCTURE,0) = 1.000000; -NODES[348](IS_STRUCTURE,0) = 1.000000; -NODES[349](IS_STRUCTURE,0) = 1.000000; -NODES[350](IS_STRUCTURE,0) = 1.000000; -NODES[351](IS_STRUCTURE,0) = 1.000000; -NODES[352](IS_STRUCTURE,0) = 1.000000; -NODES[353](IS_STRUCTURE,0) = 1.000000; -NODES[354](IS_STRUCTURE,0) = 1.000000; -NODES[355](IS_STRUCTURE,0) = 1.000000; -NODES[356](IS_STRUCTURE,0) = 1.000000; -NODES[357](IS_STRUCTURE,0) = 1.000000; -NODES[358](IS_STRUCTURE,0) = 1.000000; -NODES[359](IS_STRUCTURE,0) = 1.000000; -NODES[360](IS_STRUCTURE,0) = 1.000000; -NODES[361](IS_STRUCTURE,0) = 1.000000; -NODES[362](IS_STRUCTURE,0) = 1.000000; -NODES[363](IS_STRUCTURE,0) = 1.000000; -NODES[364](IS_STRUCTURE,0) = 1.000000; -NODES[365](IS_STRUCTURE,0) = 1.000000; -NODES[366](IS_STRUCTURE,0) = 1.000000; -NODES[367](IS_STRUCTURE,0) = 1.000000; -NODES[368](IS_STRUCTURE,0) = 1.000000; -NODES[369](IS_STRUCTURE,0) = 1.000000; -NODES[370](IS_STRUCTURE,0) = 1.000000; -NODES[371](IS_STRUCTURE,0) = 1.000000; -NODES[372](IS_STRUCTURE,0) = 1.000000; -NODES[373](IS_STRUCTURE,0) = 1.000000; -NODES[374](IS_STRUCTURE,0) = 1.000000; -NODES[375](IS_STRUCTURE,0) = 1.000000; -NODES[376](IS_STRUCTURE,0) = 1.000000; -NODES[377](IS_STRUCTURE,0) = 1.000000; -NODES[378](IS_STRUCTURE,0) = 1.000000; -NODES[379](IS_STRUCTURE,0) = 1.000000; -NODES[380](IS_STRUCTURE,0) = 1.000000; -NODES[381](IS_STRUCTURE,0) = 1.000000; -NODES[382](IS_STRUCTURE,0) = 1.000000; -NODES[383](IS_STRUCTURE,0) = 1.000000; -NODES[384](IS_STRUCTURE,0) = 1.000000; -NODES[385](IS_STRUCTURE,0) = 1.000000; -NODES[386](IS_STRUCTURE,0) = 1.000000; -NODES[387](IS_STRUCTURE,0) = 1.000000; -NODES[388](IS_STRUCTURE,0) = 1.000000; -NODES[389](IS_STRUCTURE,0) = 1.000000; -NODES[390](IS_STRUCTURE,0) = 1.000000; -NODES[391](IS_STRUCTURE,0) = 1.000000; -NODES[392](IS_STRUCTURE,0) = 1.000000; -NODES[393](IS_STRUCTURE,0) = 1.000000; -NODES[394](IS_STRUCTURE,0) = 1.000000; -NODES[395](IS_STRUCTURE,0) = 1.000000; -NODES[396](IS_STRUCTURE,0) = 1.000000; -NODES[397](IS_STRUCTURE,0) = 1.000000; -NODES[398](IS_STRUCTURE,0) = 1.000000; -NODES[399](IS_STRUCTURE,0) = 1.000000; -NODES[400](IS_STRUCTURE,0) = 1.000000; -NODES[401](IS_STRUCTURE,0) = 1.000000; -NODES[402](IS_STRUCTURE,0) = 1.000000; -NODES[403](IS_STRUCTURE,0) = 1.000000; -NODES[404](IS_STRUCTURE,0) = 1.000000; -NODES[405](IS_STRUCTURE,0) = 1.000000; -NODES[406](IS_STRUCTURE,0) = 1.000000; -NODES[407](IS_STRUCTURE,0) = 1.000000; -NODES[408](IS_STRUCTURE,0) = 1.000000; -NODES[409](IS_STRUCTURE,0) = 1.000000; -NODES[410](IS_STRUCTURE,0) = 1.000000; -NODES[411](IS_STRUCTURE,0) = 1.000000; -NODES[412](IS_STRUCTURE,0) = 1.000000; -NODES[413](IS_STRUCTURE,0) = 1.000000; -NODES[414](IS_STRUCTURE,0) = 1.000000; -NODES[415](IS_STRUCTURE,0) = 1.000000; -NODES[416](IS_STRUCTURE,0) = 1.000000; -NODES[417](IS_STRUCTURE,0) = 1.000000; -NODES[418](IS_STRUCTURE,0) = 1.000000; -NODES[419](IS_STRUCTURE,0) = 1.000000; -NODES[420](IS_STRUCTURE,0) = 1.000000; -NODES[421](IS_STRUCTURE,0) = 1.000000; -NODES[422](IS_STRUCTURE,0) = 1.000000; -NODES[423](IS_STRUCTURE,0) = 1.000000; -NODES[424](IS_STRUCTURE,0) = 1.000000; -NODES[425](IS_STRUCTURE,0) = 1.000000; -NODES[426](IS_STRUCTURE,0) = 1.000000; -NODES[427](IS_STRUCTURE,0) = 1.000000; -NODES[428](IS_STRUCTURE,0) = 1.000000; -NODES[429](IS_STRUCTURE,0) = 1.000000; -NODES[430](IS_STRUCTURE,0) = 1.000000; -NODES[431](IS_STRUCTURE,0) = 1.000000; -NODES[432](IS_STRUCTURE,0) = 1.000000; -NODES[433](IS_STRUCTURE,0) = 1.000000; -NODES[434](IS_STRUCTURE,0) = 1.000000; -NODES[435](IS_STRUCTURE,0) = 1.000000; -NODES[436](IS_STRUCTURE,0) = 1.000000; -NODES[437](IS_STRUCTURE,0) = 1.000000; -NODES[438](IS_STRUCTURE,0) = 1.000000; -NODES[439](IS_STRUCTURE,0) = 1.000000; -NODES[440](IS_STRUCTURE,0) = 1.000000; -NODES[441](IS_STRUCTURE,0) = 1.000000; -NODES[442](IS_STRUCTURE,0) = 1.000000; -NODES[443](IS_STRUCTURE,0) = 1.000000; -NODES[444](IS_STRUCTURE,0) = 1.000000; -NODES[445](IS_STRUCTURE,0) = 1.000000; -NODES[446](IS_STRUCTURE,0) = 1.000000; -NODES[447](IS_STRUCTURE,0) = 1.000000; -NODES[448](IS_STRUCTURE,0) = 1.000000; -NODES[449](IS_STRUCTURE,0) = 1.000000; -NODES[450](IS_STRUCTURE,0) = 1.000000; -NODES[451](IS_STRUCTURE,0) = 1.000000; -NODES[452](IS_STRUCTURE,0) = 1.000000; -NODES[453](IS_STRUCTURE,0) = 1.000000; -NODES[454](IS_STRUCTURE,0) = 1.000000; -NODES[455](IS_STRUCTURE,0) = 1.000000; -NODES[456](IS_STRUCTURE,0) = 1.000000; -NODES[457](IS_STRUCTURE,0) = 1.000000; -NODES[458](IS_STRUCTURE,0) = 1.000000; -NODES[459](IS_STRUCTURE,0) = 1.000000; -NODES[460](IS_STRUCTURE,0) = 1.000000; -NODES[461](IS_STRUCTURE,0) = 1.000000; -NODES[462](IS_STRUCTURE,0) = 1.000000; -NODES[463](IS_STRUCTURE,0) = 1.000000; -NODES[464](IS_STRUCTURE,0) = 1.000000; -NODES[465](IS_STRUCTURE,0) = 1.000000; -NODES[466](IS_STRUCTURE,0) = 1.000000; -NODES[467](IS_STRUCTURE,0) = 1.000000; -NODES[468](IS_STRUCTURE,0) = 1.000000; -NODES[469](IS_STRUCTURE,0) = 1.000000; -NODES[470](IS_STRUCTURE,0) = 1.000000; -NODES[471](IS_STRUCTURE,0) = 1.000000; -NODES[472](IS_STRUCTURE,0) = 1.000000; -NODES[473](IS_STRUCTURE,0) = 1.000000; -NODES[474](IS_STRUCTURE,0) = 1.000000; -NODES[475](IS_STRUCTURE,0) = 1.000000; -NODES[476](IS_STRUCTURE,0) = 1.000000; -NODES[477](IS_STRUCTURE,0) = 1.000000; -NODES[478](IS_STRUCTURE,0) = 1.000000; -NODES[479](IS_STRUCTURE,0) = 1.000000; -NODES[480](IS_STRUCTURE,0) = 1.000000; -NODES[481](IS_STRUCTURE,0) = 1.000000; -NODES[482](IS_STRUCTURE,0) = 1.000000; -NODES[483](IS_STRUCTURE,0) = 1.000000; -NODES[484](IS_STRUCTURE,0) = 1.000000; -NODES[485](IS_STRUCTURE,0) = 1.000000; -NODES[486](IS_STRUCTURE,0) = 1.000000; -NODES[487](IS_STRUCTURE,0) = 1.000000; -NODES[488](IS_STRUCTURE,0) = 1.000000; -NODES[489](IS_STRUCTURE,0) = 1.000000; -NODES[490](IS_STRUCTURE,0) = 1.000000; -NODES[491](IS_STRUCTURE,0) = 1.000000; -NODES[492](IS_STRUCTURE,0) = 1.000000; -NODES[493](IS_STRUCTURE,0) = 1.000000; -NODES[494](IS_STRUCTURE,0) = 1.000000; -NODES[495](IS_STRUCTURE,0) = 1.000000; -NODES[496](IS_STRUCTURE,0) = 1.000000; -NODES[497](IS_STRUCTURE,0) = 1.000000; -NODES[498](IS_STRUCTURE,0) = 1.000000; -NODES[499](IS_STRUCTURE,0) = 1.000000; -NODES[500](IS_STRUCTURE,0) = 1.000000; -NODES[501](IS_STRUCTURE,0) = 1.000000; -NODES[502](IS_STRUCTURE,0) = 1.000000; -NODES[503](IS_STRUCTURE,0) = 1.000000; -NODES[504](IS_STRUCTURE,0) = 1.000000; -NODES[505](IS_STRUCTURE,0) = 1.000000; -NODES[506](IS_STRUCTURE,0) = 1.000000; -NODES[507](IS_STRUCTURE,0) = 1.000000; -NODES[508](IS_STRUCTURE,0) = 1.000000; -NODES[509](IS_STRUCTURE,0) = 1.000000; -NODES[510](IS_STRUCTURE,0) = 1.000000; -NODES[511](IS_STRUCTURE,0) = 1.000000; -NODES[512](IS_STRUCTURE,0) = 1.000000; -NODES[513](IS_STRUCTURE,0) = 1.000000; -NODES[514](IS_STRUCTURE,0) = 1.000000; -NODES[515](IS_STRUCTURE,0) = 1.000000; -NODES[516](IS_STRUCTURE,0) = 1.000000; -NODES[517](IS_STRUCTURE,0) = 1.000000; -NODES[518](IS_STRUCTURE,0) = 1.000000; -NODES[519](IS_STRUCTURE,0) = 1.000000; -NODES[520](IS_STRUCTURE,0) = 1.000000; -NODES[521](IS_STRUCTURE,0) = 1.000000; -NODES[522](IS_STRUCTURE,0) = 1.000000; -NODES[523](IS_STRUCTURE,0) = 1.000000; -NODES[524](IS_STRUCTURE,0) = 1.000000; -NODES[525](IS_STRUCTURE,0) = 1.000000; -NODES[526](IS_STRUCTURE,0) = 1.000000; -NODES[527](IS_STRUCTURE,0) = 1.000000; -NODES[528](IS_STRUCTURE,0) = 1.000000; -NODES[529](IS_STRUCTURE,0) = 1.000000; -NODES[530](IS_STRUCTURE,0) = 1.000000; -NODES[531](IS_STRUCTURE,0) = 1.000000; -NODES[532](IS_STRUCTURE,0) = 1.000000; -NODES[533](IS_STRUCTURE,0) = 1.000000; -NODES[534](IS_STRUCTURE,0) = 1.000000; -NODES[535](IS_STRUCTURE,0) = 1.000000; -NODES[536](IS_STRUCTURE,0) = 1.000000; -NODES[537](IS_STRUCTURE,0) = 1.000000; -NODES[538](IS_STRUCTURE,0) = 1.000000; -NODES[539](IS_STRUCTURE,0) = 1.000000; -NODES[540](IS_STRUCTURE,0) = 1.000000; -NODES[541](IS_STRUCTURE,0) = 1.000000; -NODES[542](IS_STRUCTURE,0) = 1.000000; -NODES[543](IS_STRUCTURE,0) = 1.000000; -NODES[544](IS_STRUCTURE,0) = 1.000000; -NODES[545](IS_STRUCTURE,0) = 1.000000; -NODES[546](IS_STRUCTURE,0) = 1.000000; -NODES[547](IS_STRUCTURE,0) = 1.000000; -NODES[548](IS_STRUCTURE,0) = 1.000000; -NODES[549](IS_STRUCTURE,0) = 1.000000; -NODES[550](IS_STRUCTURE,0) = 1.000000; -NODES[551](IS_STRUCTURE,0) = 1.000000; -NODES[552](IS_STRUCTURE,0) = 1.000000; -NODES[553](IS_STRUCTURE,0) = 1.000000; -NODES[554](IS_STRUCTURE,0) = 1.000000; -NODES[555](IS_STRUCTURE,0) = 1.000000; -NODES[556](IS_STRUCTURE,0) = 1.000000; -NODES[557](IS_STRUCTURE,0) = 1.000000; -NODES[558](IS_STRUCTURE,0) = 1.000000; -NODES[559](IS_STRUCTURE,0) = 1.000000; -NODES[560](IS_STRUCTURE,0) = 1.000000; -NODES[561](IS_STRUCTURE,0) = 1.000000; -NODES[562](IS_STRUCTURE,0) = 1.000000; -NODES[563](IS_STRUCTURE,0) = 1.000000; -NODES[564](IS_STRUCTURE,0) = 1.000000; -NODES[565](IS_STRUCTURE,0) = 1.000000; -NODES[566](IS_STRUCTURE,0) = 1.000000; -NODES[567](IS_STRUCTURE,0) = 1.000000; -NODES[568](IS_STRUCTURE,0) = 1.000000; -NODES[569](IS_STRUCTURE,0) = 1.000000; -NODES[570](IS_STRUCTURE,0) = 1.000000; -NODES[571](IS_STRUCTURE,0) = 1.000000; -NODES[572](IS_STRUCTURE,0) = 1.000000; -NODES[573](IS_STRUCTURE,0) = 1.000000; -NODES[574](IS_STRUCTURE,0) = 1.000000; -NODES[575](IS_STRUCTURE,0) = 1.000000; -NODES[576](IS_STRUCTURE,0) = 1.000000; -NODES[577](IS_STRUCTURE,0) = 1.000000; -NODES[578](IS_STRUCTURE,0) = 1.000000; -NODES[579](IS_STRUCTURE,0) = 1.000000; -NODES[580](IS_STRUCTURE,0) = 1.000000; -NODES[581](IS_STRUCTURE,0) = 1.000000; -NODES[582](IS_STRUCTURE,0) = 1.000000; -NODES[583](IS_STRUCTURE,0) = 1.000000; -NODES[584](IS_STRUCTURE,0) = 1.000000; -NODES[585](IS_STRUCTURE,0) = 1.000000; -NODES[586](IS_STRUCTURE,0) = 1.000000; -NODES[587](IS_STRUCTURE,0) = 1.000000; -NODES[588](IS_STRUCTURE,0) = 1.000000; -NODES[589](IS_STRUCTURE,0) = 1.000000; -NODES[590](IS_STRUCTURE,0) = 1.000000; -NODES[591](IS_STRUCTURE,0) = 1.000000; -NODES[592](IS_STRUCTURE,0) = 1.000000; -NODES[593](IS_STRUCTURE,0) = 1.000000; -NODES[594](IS_STRUCTURE,0) = 1.000000; -NODES[595](IS_STRUCTURE,0) = 1.000000; -NODES[596](IS_STRUCTURE,0) = 1.000000; -NODES[597](IS_STRUCTURE,0) = 1.000000; -NODES[598](IS_STRUCTURE,0) = 1.000000; -NODES[599](IS_STRUCTURE,0) = 1.000000; -NODES[600](IS_STRUCTURE,0) = 1.000000; -NODES[601](IS_STRUCTURE,0) = 1.000000; -NODES[602](IS_STRUCTURE,0) = 1.000000; -NODES[603](IS_STRUCTURE,0) = 1.000000; -NODES[604](IS_STRUCTURE,0) = 1.000000; -NODES[605](IS_STRUCTURE,0) = 1.000000; -NODES[606](IS_STRUCTURE,0) = 1.000000; -NODES[607](IS_STRUCTURE,0) = 1.000000; -NODES[608](IS_STRUCTURE,0) = 1.000000; -NODES[609](IS_STRUCTURE,0) = 1.000000; -NODES[610](IS_STRUCTURE,0) = 1.000000; -NODES[611](IS_STRUCTURE,0) = 1.000000; -NODES[612](IS_STRUCTURE,0) = 1.000000; -NODES[613](IS_STRUCTURE,0) = 1.000000; -NODES[614](IS_STRUCTURE,0) = 1.000000; -NODES[615](IS_STRUCTURE,0) = 1.000000; -NODES[616](IS_STRUCTURE,0) = 1.000000; -NODES[617](IS_STRUCTURE,0) = 1.000000; -NODES[618](IS_STRUCTURE,0) = 1.000000; -NODES[619](IS_STRUCTURE,0) = 1.000000; -NODES[620](IS_STRUCTURE,0) = 1.000000; -NODES[621](IS_STRUCTURE,0) = 1.000000; -NODES[622](IS_STRUCTURE,0) = 1.000000; -NODES[623](IS_STRUCTURE,0) = 1.000000; -NODES[624](IS_STRUCTURE,0) = 1.000000; -NODES[625](IS_STRUCTURE,0) = 1.000000; -NODES[626](IS_STRUCTURE,0) = 1.000000; -NODES[627](IS_STRUCTURE,0) = 1.000000; -NODES[628](IS_STRUCTURE,0) = 1.000000; -NODES[629](IS_STRUCTURE,0) = 1.000000; -NODES[630](IS_STRUCTURE,0) = 1.000000; -NODES[631](IS_STRUCTURE,0) = 1.000000; -NODES[632](IS_STRUCTURE,0) = 1.000000; -NODES[633](IS_STRUCTURE,0) = 1.000000; -NODES[634](IS_STRUCTURE,0) = 1.000000; -NODES[635](IS_STRUCTURE,0) = 1.000000; -NODES[636](IS_STRUCTURE,0) = 1.000000; -NODES[637](IS_STRUCTURE,0) = 1.000000; -NODES[638](IS_STRUCTURE,0) = 1.000000; -NODES[639](IS_STRUCTURE,0) = 1.000000; -NODES[640](IS_STRUCTURE,0) = 1.000000; -NODES[641](IS_STRUCTURE,0) = 1.000000; -NODES[642](IS_STRUCTURE,0) = 1.000000; -NODES[643](IS_STRUCTURE,0) = 1.000000; -NODES[644](IS_STRUCTURE,0) = 1.000000; -NODES[645](IS_STRUCTURE,0) = 1.000000; -NODES[646](IS_STRUCTURE,0) = 1.000000; -NODES[647](IS_STRUCTURE,0) = 1.000000; -NODES[648](IS_STRUCTURE,0) = 1.000000; -NODES[649](IS_STRUCTURE,0) = 1.000000; -NODES[650](IS_STRUCTURE,0) = 1.000000; -NODES[651](IS_STRUCTURE,0) = 1.000000; -NODES[652](IS_STRUCTURE,0) = 1.000000; -NODES[653](IS_STRUCTURE,0) = 1.000000; -NODES[654](IS_STRUCTURE,0) = 1.000000; -NODES[655](IS_STRUCTURE,0) = 1.000000; -NODES[656](IS_STRUCTURE,0) = 1.000000; -NODES[657](IS_STRUCTURE,0) = 1.000000; -NODES[658](IS_STRUCTURE,0) = 1.000000; -NODES[659](IS_STRUCTURE,0) = 1.000000; -NODES[660](IS_STRUCTURE,0) = 1.000000; -NODES[661](IS_STRUCTURE,0) = 1.000000; -NODES[662](IS_STRUCTURE,0) = 1.000000; -NODES[663](IS_STRUCTURE,0) = 1.000000; -NODES[664](IS_STRUCTURE,0) = 1.000000; -NODES[665](IS_STRUCTURE,0) = 1.000000; -NODES[666](IS_STRUCTURE,0) = 1.000000; -NODES[667](IS_STRUCTURE,0) = 1.000000; -NODES[668](IS_STRUCTURE,0) = 1.000000; -NODES[669](IS_STRUCTURE,0) = 1.000000; -NODES[670](IS_STRUCTURE,0) = 1.000000; -NODES[671](IS_STRUCTURE,0) = 1.000000; -NODES[672](IS_STRUCTURE,0) = 1.000000; -NODES[673](IS_STRUCTURE,0) = 1.000000; -NODES[674](IS_STRUCTURE,0) = 1.000000; -NODES[675](IS_STRUCTURE,0) = 1.000000; -NODES[676](IS_STRUCTURE,0) = 1.000000; -NODES[677](IS_STRUCTURE,0) = 1.000000; -NODES[678](IS_STRUCTURE,0) = 1.000000; -NODES[679](IS_STRUCTURE,0) = 1.000000; -NODES[680](IS_STRUCTURE,0) = 1.000000; -NODES[681](IS_STRUCTURE,0) = 1.000000; -NODES[682](IS_STRUCTURE,0) = 1.000000; -NODES[683](IS_STRUCTURE,0) = 1.000000; -NODES[684](IS_STRUCTURE,0) = 1.000000; -NODES[685](IS_STRUCTURE,0) = 1.000000; -NODES[686](IS_STRUCTURE,0) = 1.000000; -NODES[687](IS_STRUCTURE,0) = 1.000000; -NODES[688](IS_STRUCTURE,0) = 1.000000; -NODES[689](IS_STRUCTURE,0) = 1.000000; -NODES[690](IS_STRUCTURE,0) = 1.000000; -NODES[691](IS_STRUCTURE,0) = 1.000000; -NODES[692](IS_STRUCTURE,0) = 1.000000; -NODES[693](IS_STRUCTURE,0) = 1.000000; -NODES[694](IS_STRUCTURE,0) = 1.000000; -NODES[695](IS_STRUCTURE,0) = 1.000000; -NODES[696](IS_STRUCTURE,0) = 1.000000; -NODES[697](IS_STRUCTURE,0) = 1.000000; -NODES[698](IS_STRUCTURE,0) = 1.000000; -NODES[699](IS_STRUCTURE,0) = 1.000000; -NODES[700](IS_STRUCTURE,0) = 1.000000; -NODES[701](IS_STRUCTURE,0) = 1.000000; -NODES[702](IS_STRUCTURE,0) = 1.000000; -NODES[703](IS_STRUCTURE,0) = 1.000000; -NODES[704](IS_STRUCTURE,0) = 1.000000; -NODES[705](IS_STRUCTURE,0) = 1.000000; -NODES[706](IS_STRUCTURE,0) = 1.000000; -NODES[707](IS_STRUCTURE,0) = 1.000000; -NODES[708](IS_STRUCTURE,0) = 1.000000; -NODES[709](IS_STRUCTURE,0) = 1.000000; -NODES[710](IS_STRUCTURE,0) = 1.000000; -NODES[711](IS_STRUCTURE,0) = 1.000000; -NODES[712](IS_STRUCTURE,0) = 1.000000; -NODES[713](IS_STRUCTURE,0) = 1.000000; -NODES[714](IS_STRUCTURE,0) = 1.000000; -NODES[715](IS_STRUCTURE,0) = 1.000000; -NODES[716](IS_STRUCTURE,0) = 1.000000; -NODES[717](IS_STRUCTURE,0) = 1.000000; -NODES[718](IS_STRUCTURE,0) = 1.000000; -NODES[719](IS_STRUCTURE,0) = 1.000000; -NODES[720](IS_STRUCTURE,0) = 1.000000; -NODES[721](IS_STRUCTURE,0) = 1.000000; -NODES[722](IS_STRUCTURE,0) = 1.000000; -NODES[723](IS_STRUCTURE,0) = 1.000000; -NODES[724](IS_STRUCTURE,0) = 1.000000; -NODES[725](IS_STRUCTURE,0) = 1.000000; -NODES[726](IS_STRUCTURE,0) = 1.000000; -NODES[727](IS_STRUCTURE,0) = 1.000000; -NODES[728](IS_STRUCTURE,0) = 1.000000; -NODES[729](IS_STRUCTURE,0) = 1.000000; -NODES[730](IS_STRUCTURE,0) = 1.000000; -NODES[731](IS_STRUCTURE,0) = 1.000000; -NODES[732](IS_STRUCTURE,0) = 1.000000; -NODES[733](IS_STRUCTURE,0) = 1.000000; -NODES[734](IS_STRUCTURE,0) = 1.000000; -NODES[735](IS_STRUCTURE,0) = 1.000000; -NODES[736](IS_STRUCTURE,0) = 1.000000; -NODES[737](IS_STRUCTURE,0) = 1.000000; -NODES[738](IS_STRUCTURE,0) = 1.000000; -NODES[739](IS_STRUCTURE,0) = 1.000000; -NODES[740](IS_STRUCTURE,0) = 1.000000; -NODES[741](IS_STRUCTURE,0) = 1.000000; -NODES[742](IS_STRUCTURE,0) = 1.000000; -NODES[743](IS_STRUCTURE,0) = 1.000000; -NODES[744](IS_STRUCTURE,0) = 1.000000; -NODES[745](IS_STRUCTURE,0) = 1.000000; -NODES[746](IS_STRUCTURE,0) = 1.000000; -NODES[747](IS_STRUCTURE,0) = 1.000000; -NODES[748](IS_STRUCTURE,0) = 1.000000; -NODES[749](IS_STRUCTURE,0) = 1.000000; -NODES[750](IS_STRUCTURE,0) = 1.000000; -NODES[751](IS_STRUCTURE,0) = 1.000000; -NODES[752](IS_STRUCTURE,0) = 1.000000; -NODES[753](IS_STRUCTURE,0) = 1.000000; -NODES[754](IS_STRUCTURE,0) = 1.000000; -NODES[755](IS_STRUCTURE,0) = 1.000000; -NODES[756](IS_STRUCTURE,0) = 1.000000; -NODES[757](IS_STRUCTURE,0) = 1.000000; -NODES[758](IS_STRUCTURE,0) = 1.000000; -NODES[759](IS_STRUCTURE,0) = 1.000000; -NODES[760](IS_STRUCTURE,0) = 1.000000; -NODES[761](IS_STRUCTURE,0) = 1.000000; -NODES[762](IS_STRUCTURE,0) = 1.000000; -NODES[763](IS_STRUCTURE,0) = 1.000000; -NODES[764](IS_STRUCTURE,0) = 1.000000; -NODES[765](IS_STRUCTURE,0) = 1.000000; -NODES[766](IS_STRUCTURE,0) = 1.000000; -NODES[767](IS_STRUCTURE,0) = 1.000000; -NODES[768](IS_STRUCTURE,0) = 1.000000; -NODES[769](IS_STRUCTURE,0) = 1.000000; -NODES[770](IS_STRUCTURE,0) = 1.000000; -NODES[771](IS_STRUCTURE,0) = 1.000000; -NODES[772](IS_STRUCTURE,0) = 1.000000; -NODES[773](IS_STRUCTURE,0) = 1.000000; -NODES[774](IS_STRUCTURE,0) = 1.000000; -NODES[775](IS_STRUCTURE,0) = 1.000000; -NODES[776](IS_STRUCTURE,0) = 1.000000; -NODES[777](IS_STRUCTURE,0) = 1.000000; -NODES[778](IS_STRUCTURE,0) = 1.000000; -NODES[779](IS_STRUCTURE,0) = 1.000000; -NODES[780](IS_STRUCTURE,0) = 1.000000; -NODES[781](IS_STRUCTURE,0) = 1.000000; -NODES[782](IS_STRUCTURE,0) = 1.000000; -NODES[783](IS_STRUCTURE,0) = 1.000000; -NODES[784](IS_STRUCTURE,0) = 1.000000; -NODES[785](IS_STRUCTURE,0) = 1.000000; -NODES[786](IS_STRUCTURE,0) = 1.000000; -NODES[787](IS_STRUCTURE,0) = 1.000000; -NODES[788](IS_STRUCTURE,0) = 1.000000; -NODES[789](IS_STRUCTURE,0) = 1.000000; -NODES[790](IS_STRUCTURE,0) = 1.000000; -NODES[791](IS_STRUCTURE,0) = 1.000000; -NODES[792](IS_STRUCTURE,0) = 1.000000; -NODES[793](IS_STRUCTURE,0) = 1.000000; -NODES[794](IS_STRUCTURE,0) = 1.000000; -NODES[795](IS_STRUCTURE,0) = 1.000000; -NODES[796](IS_STRUCTURE,0) = 1.000000; -NODES[797](IS_STRUCTURE,0) = 1.000000; -NODES[798](IS_STRUCTURE,0) = 1.000000; -NODES[799](IS_STRUCTURE,0) = 1.000000; -NODES[800](IS_STRUCTURE,0) = 1.000000; -NODES[801](IS_STRUCTURE,0) = 1.000000; -NODES[802](IS_STRUCTURE,0) = 1.000000; -NODES[803](IS_STRUCTURE,0) = 1.000000; -NODES[804](IS_STRUCTURE,0) = 1.000000; -NODES[805](IS_STRUCTURE,0) = 1.000000; -NODES[806](IS_STRUCTURE,0) = 1.000000; -NODES[807](IS_STRUCTURE,0) = 1.000000; -NODES[808](IS_STRUCTURE,0) = 1.000000; -NODES[809](IS_STRUCTURE,0) = 1.000000; -NODES[810](IS_STRUCTURE,0) = 1.000000; -NODES[811](IS_STRUCTURE,0) = 1.000000; -NODES[812](IS_STRUCTURE,0) = 1.000000; -NODES[813](IS_STRUCTURE,0) = 1.000000; -NODES[814](IS_STRUCTURE,0) = 1.000000; -NODES[815](IS_STRUCTURE,0) = 1.000000; -NODES[816](IS_STRUCTURE,0) = 1.000000; -NODES[817](IS_STRUCTURE,0) = 1.000000; -NODES[818](IS_STRUCTURE,0) = 1.000000; -NODES[819](IS_STRUCTURE,0) = 1.000000; -NODES[820](IS_STRUCTURE,0) = 1.000000; -NODES[821](IS_STRUCTURE,0) = 1.000000; -NODES[822](IS_STRUCTURE,0) = 1.000000; -NODES[823](IS_STRUCTURE,0) = 1.000000; -NODES[824](IS_STRUCTURE,0) = 1.000000; -NODES[825](IS_STRUCTURE,0) = 1.000000; -NODES[826](IS_STRUCTURE,0) = 1.000000; -NODES[827](IS_STRUCTURE,0) = 1.000000; -NODES[828](IS_STRUCTURE,0) = 1.000000; -NODES[829](IS_STRUCTURE,0) = 1.000000; -NODES[830](IS_STRUCTURE,0) = 1.000000; -NODES[831](IS_STRUCTURE,0) = 1.000000; -NODES[832](IS_STRUCTURE,0) = 1.000000; -NODES[833](IS_STRUCTURE,0) = 1.000000; -NODES[834](IS_STRUCTURE,0) = 1.000000; -NODES[835](IS_STRUCTURE,0) = 1.000000; -NODES[836](IS_STRUCTURE,0) = 1.000000; -NODES[837](IS_STRUCTURE,0) = 1.000000; -NODES[838](IS_STRUCTURE,0) = 1.000000; -NODES[839](IS_STRUCTURE,0) = 1.000000; -NODES[840](IS_STRUCTURE,0) = 1.000000; -NODES[841](IS_STRUCTURE,0) = 1.000000; -NODES[842](IS_STRUCTURE,0) = 1.000000; -NODES[843](IS_STRUCTURE,0) = 1.000000; -NODES[844](IS_STRUCTURE,0) = 1.000000; -NODES[845](IS_STRUCTURE,0) = 1.000000; -NODES[846](IS_STRUCTURE,0) = 1.000000; -NODES[847](IS_STRUCTURE,0) = 1.000000; -NODES[848](IS_STRUCTURE,0) = 1.000000; -NODES[849](IS_STRUCTURE,0) = 1.000000; -NODES[850](IS_STRUCTURE,0) = 1.000000; -NODES[851](IS_STRUCTURE,0) = 1.000000; -NODES[852](IS_STRUCTURE,0) = 1.000000; -NODES[853](IS_STRUCTURE,0) = 1.000000; -NODES[854](IS_STRUCTURE,0) = 1.000000; -NODES[855](IS_STRUCTURE,0) = 1.000000; -NODES[856](IS_STRUCTURE,0) = 1.000000; -NODES[857](IS_STRUCTURE,0) = 1.000000; -NODES[858](IS_STRUCTURE,0) = 1.000000; -NODES[859](IS_STRUCTURE,0) = 1.000000; -NODES[860](IS_STRUCTURE,0) = 1.000000; -NODES[861](IS_STRUCTURE,0) = 1.000000; -NODES[862](IS_STRUCTURE,0) = 1.000000; -NODES[863](IS_STRUCTURE,0) = 1.000000; -NODES[864](IS_STRUCTURE,0) = 1.000000; -NODES[865](IS_STRUCTURE,0) = 1.000000; -NODES[866](IS_STRUCTURE,0) = 1.000000; -NODES[867](IS_STRUCTURE,0) = 1.000000; -NODES[868](IS_STRUCTURE,0) = 1.000000; -NODES[869](IS_STRUCTURE,0) = 1.000000; -NODES[870](IS_STRUCTURE,0) = 1.000000; -NODES[871](IS_STRUCTURE,0) = 1.000000; -NODES[872](IS_STRUCTURE,0) = 1.000000; -NODES[873](IS_STRUCTURE,0) = 1.000000; -NODES[874](IS_STRUCTURE,0) = 1.000000; -NODES[875](IS_STRUCTURE,0) = 1.000000; -NODES[876](IS_STRUCTURE,0) = 1.000000; -NODES[877](IS_STRUCTURE,0) = 1.000000; -NODES[878](IS_STRUCTURE,0) = 1.000000; -NODES[879](IS_STRUCTURE,0) = 1.000000; -NODES[880](IS_STRUCTURE,0) = 1.000000; -NODES[881](IS_STRUCTURE,0) = 1.000000; -NODES[882](IS_STRUCTURE,0) = 1.000000; -NODES[883](IS_STRUCTURE,0) = 1.000000; -NODES[884](IS_STRUCTURE,0) = 1.000000; -NODES[885](IS_STRUCTURE,0) = 1.000000; -NODES[886](IS_STRUCTURE,0) = 1.000000; -NODES[887](IS_STRUCTURE,0) = 1.000000; -NODES[888](IS_STRUCTURE,0) = 1.000000; -NODES[889](IS_STRUCTURE,0) = 1.000000; -NODES[890](IS_STRUCTURE,0) = 1.000000; -NODES[891](IS_STRUCTURE,0) = 1.000000; -NODES[892](IS_STRUCTURE,0) = 1.000000; -NODES[893](IS_STRUCTURE,0) = 1.000000; -NODES[894](IS_STRUCTURE,0) = 1.000000; -NODES[895](IS_STRUCTURE,0) = 1.000000; -NODES[896](IS_STRUCTURE,0) = 1.000000; -NODES[897](IS_STRUCTURE,0) = 1.000000; -NODES[898](IS_STRUCTURE,0) = 1.000000; -NODES[899](IS_STRUCTURE,0) = 1.000000; -NODES[900](IS_STRUCTURE,0) = 1.000000; -NODES[901](IS_STRUCTURE,0) = 1.000000; -NODES[902](IS_STRUCTURE,0) = 1.000000; -NODES[903](IS_STRUCTURE,0) = 1.000000; -NODES[904](IS_STRUCTURE,0) = 1.000000; -NODES[905](IS_STRUCTURE,0) = 1.000000; -NODES[906](IS_STRUCTURE,0) = 1.000000; -NODES[907](IS_STRUCTURE,0) = 1.000000; -NODES[908](IS_STRUCTURE,0) = 1.000000; -NODES[909](IS_STRUCTURE,0) = 1.000000; -NODES[910](IS_STRUCTURE,0) = 1.000000; -NODES[911](IS_STRUCTURE,0) = 1.000000; -NODES[912](IS_STRUCTURE,0) = 1.000000; -NODES[913](IS_STRUCTURE,0) = 1.000000; -NODES[914](IS_STRUCTURE,0) = 1.000000; -NODES[915](IS_STRUCTURE,0) = 1.000000; -NODES[916](IS_STRUCTURE,0) = 1.000000; -NODES[917](IS_STRUCTURE,0) = 1.000000; -NODES[918](IS_STRUCTURE,0) = 1.000000; -NODES[919](IS_STRUCTURE,0) = 1.000000; -NODES[920](IS_STRUCTURE,0) = 1.000000; -NODES[921](IS_STRUCTURE,0) = 1.000000; -NODES[922](IS_STRUCTURE,0) = 1.000000; -NODES[923](IS_STRUCTURE,0) = 1.000000; -NODES[924](IS_STRUCTURE,0) = 1.000000; -NODES[925](IS_STRUCTURE,0) = 1.000000; -NODES[926](IS_STRUCTURE,0) = 1.000000; -NODES[927](IS_STRUCTURE,0) = 1.000000; -NODES[928](IS_STRUCTURE,0) = 1.000000; -NODES[929](IS_STRUCTURE,0) = 1.000000; -NODES[930](IS_STRUCTURE,0) = 1.000000; -NODES[931](IS_STRUCTURE,0) = 1.000000; -NODES[932](IS_STRUCTURE,0) = 1.000000; -NODES[933](IS_STRUCTURE,0) = 1.000000; -NODES[934](IS_STRUCTURE,0) = 1.000000; -NODES[935](IS_STRUCTURE,0) = 1.000000; -NODES[936](IS_STRUCTURE,0) = 1.000000; -NODES[937](IS_STRUCTURE,0) = 1.000000; -NODES[938](IS_STRUCTURE,0) = 1.000000; -NODES[939](IS_STRUCTURE,0) = 1.000000; -NODES[940](IS_STRUCTURE,0) = 1.000000; -NODES[941](IS_STRUCTURE,0) = 1.000000; -NODES[942](IS_STRUCTURE,0) = 1.000000; -NODES[943](IS_STRUCTURE,0) = 1.000000; -NODES[944](IS_STRUCTURE,0) = 1.000000; -NODES[945](IS_STRUCTURE,0) = 1.000000; -NODES[946](IS_STRUCTURE,0) = 1.000000; -NODES[947](IS_STRUCTURE,0) = 1.000000; -NODES[948](IS_STRUCTURE,0) = 1.000000; -NODES[949](IS_STRUCTURE,0) = 1.000000; -NODES[950](IS_STRUCTURE,0) = 1.000000; -NODES[951](IS_STRUCTURE,0) = 1.000000; -NODES[952](IS_STRUCTURE,0) = 1.000000; -NODES[953](IS_STRUCTURE,0) = 1.000000; -NODES[954](IS_STRUCTURE,0) = 1.000000; -NODES[955](IS_STRUCTURE,0) = 1.000000; -NODES[956](IS_STRUCTURE,0) = 1.000000; -NODES[957](IS_STRUCTURE,0) = 1.000000; -NODES[958](IS_STRUCTURE,0) = 1.000000; -NODES[959](IS_STRUCTURE,0) = 1.000000; -NODES[960](IS_STRUCTURE,0) = 1.000000; -NODES[961](IS_STRUCTURE,0) = 1.000000; -NODES[962](IS_STRUCTURE,0) = 1.000000; -NODES[963](IS_STRUCTURE,0) = 1.000000; -NODES[964](IS_STRUCTURE,0) = 1.000000; -NODES[965](IS_STRUCTURE,0) = 1.000000; -NODES[966](IS_STRUCTURE,0) = 1.000000; -NODES[967](IS_STRUCTURE,0) = 1.000000; -NODES[968](IS_STRUCTURE,0) = 1.000000; -NODES[969](IS_STRUCTURE,0) = 1.000000; -NODES[970](IS_STRUCTURE,0) = 1.000000; -NODES[971](IS_STRUCTURE,0) = 1.000000; -NODES[972](IS_STRUCTURE,0) = 1.000000; -NODES[973](IS_STRUCTURE,0) = 1.000000; -NODES[974](IS_STRUCTURE,0) = 1.000000; -NODES[975](IS_STRUCTURE,0) = 1.000000; -NODES[976](IS_STRUCTURE,0) = 1.000000; -NODES[977](IS_STRUCTURE,0) = 1.000000; -NODES[978](IS_STRUCTURE,0) = 1.000000; -NODES[979](IS_STRUCTURE,0) = 1.000000; -NODES[980](IS_STRUCTURE,0) = 1.000000; -NODES[981](IS_STRUCTURE,0) = 1.000000; -NODES[982](IS_STRUCTURE,0) = 1.000000; -NODES[983](IS_STRUCTURE,0) = 1.000000; -NODES[984](IS_STRUCTURE,0) = 1.000000; -NODES[985](IS_STRUCTURE,0) = 1.000000; -NODES[986](IS_STRUCTURE,0) = 1.000000; -NODES[987](IS_STRUCTURE,0) = 1.000000; -NODES[988](IS_STRUCTURE,0) = 1.000000; -NODES[989](IS_STRUCTURE,0) = 1.000000; -NODES[990](IS_STRUCTURE,0) = 1.000000; -NODES[991](IS_STRUCTURE,0) = 1.000000; -NODES[992](IS_STRUCTURE,0) = 1.000000; -NODES[993](IS_STRUCTURE,0) = 1.000000; -NODES[994](IS_STRUCTURE,0) = 1.000000; -NODES[995](IS_STRUCTURE,0) = 1.000000; -NODES[996](IS_STRUCTURE,0) = 1.000000; -NODES[997](IS_STRUCTURE,0) = 1.000000; -NODES[998](IS_STRUCTURE,0) = 1.000000; -NODES[999](IS_STRUCTURE,0) = 1.000000; -NODES[1000](IS_STRUCTURE,0) = 1.000000; -NODES[1001](IS_STRUCTURE,0) = 1.000000; -NODES[1002](IS_STRUCTURE,0) = 1.000000; -NODES[1003](IS_STRUCTURE,0) = 1.000000; -NODES[1004](IS_STRUCTURE,0) = 1.000000; -NODES[1005](IS_STRUCTURE,0) = 1.000000; -NODES[1006](IS_STRUCTURE,0) = 1.000000; -NODES[1007](IS_STRUCTURE,0) = 1.000000; -NODES[1008](IS_STRUCTURE,0) = 1.000000; -NODES[1009](IS_STRUCTURE,0) = 1.000000; -NODES[1010](IS_STRUCTURE,0) = 1.000000; -NODES[1011](IS_STRUCTURE,0) = 1.000000; -NODES[1012](IS_STRUCTURE,0) = 1.000000; -NODES[1013](IS_STRUCTURE,0) = 1.000000; -NODES[1014](IS_STRUCTURE,0) = 1.000000; -NODES[1015](IS_STRUCTURE,0) = 1.000000; -NODES[1016](IS_STRUCTURE,0) = 1.000000; -NODES[1017](IS_STRUCTURE,0) = 1.000000; -NODES[1018](IS_STRUCTURE,0) = 1.000000; -NODES[1019](IS_STRUCTURE,0) = 1.000000; -NODES[1020](IS_STRUCTURE,0) = 1.000000; -NODES[1021](IS_STRUCTURE,0) = 1.000000; -NODES[1022](IS_STRUCTURE,0) = 1.000000; -NODES[1023](IS_STRUCTURE,0) = 1.000000; -NODES[1024](IS_STRUCTURE,0) = 1.000000; -NODES[1025](IS_STRUCTURE,0) = 1.000000; -NODES[1026](IS_STRUCTURE,0) = 1.000000; -NODES[1027](IS_STRUCTURE,0) = 1.000000; -NODES[1028](IS_STRUCTURE,0) = 1.000000; -NODES[1029](IS_STRUCTURE,0) = 1.000000; -NODES[1030](IS_STRUCTURE,0) = 1.000000; -NODES[1031](IS_STRUCTURE,0) = 1.000000; -NODES[1032](IS_STRUCTURE,0) = 1.000000; -NODES[1033](IS_STRUCTURE,0) = 1.000000; -NODES[1034](IS_STRUCTURE,0) = 1.000000; -NODES[1035](IS_STRUCTURE,0) = 1.000000; -NODES[1036](IS_STRUCTURE,0) = 1.000000; -NODES[1037](IS_STRUCTURE,0) = 1.000000; -NODES[1038](IS_STRUCTURE,0) = 1.000000; -NODES[1039](IS_STRUCTURE,0) = 1.000000; -NODES[1040](IS_STRUCTURE,0) = 1.000000; -NODES[1041](IS_STRUCTURE,0) = 1.000000; -NODES[1042](IS_STRUCTURE,0) = 1.000000; -NODES[1043](IS_STRUCTURE,0) = 1.000000; -NODES[1044](IS_STRUCTURE,0) = 1.000000; -NODES[1045](IS_STRUCTURE,0) = 1.000000; -NODES[1046](IS_STRUCTURE,0) = 1.000000; -NODES[1047](IS_STRUCTURE,0) = 1.000000; -NODES[1048](IS_STRUCTURE,0) = 1.000000; -NODES[1049](IS_STRUCTURE,0) = 1.000000; -NODES[1050](IS_STRUCTURE,0) = 1.000000; -NODES[1051](IS_STRUCTURE,0) = 1.000000; -NODES[1052](IS_STRUCTURE,0) = 1.000000; -NODES[1053](IS_STRUCTURE,0) = 1.000000; -NODES[1054](IS_STRUCTURE,0) = 1.000000; -NODES[1055](IS_STRUCTURE,0) = 1.000000; -NODES[1056](IS_STRUCTURE,0) = 1.000000; -NODES[1057](IS_STRUCTURE,0) = 1.000000; -NODES[1058](IS_STRUCTURE,0) = 1.000000; -NODES[1059](IS_STRUCTURE,0) = 1.000000; -NODES[1060](IS_STRUCTURE,0) = 1.000000; -NODES[1061](IS_STRUCTURE,0) = 1.000000; -NODES[1062](IS_STRUCTURE,0) = 1.000000; -NODES[1063](IS_STRUCTURE,0) = 1.000000; -NODES[1064](IS_STRUCTURE,0) = 1.000000; -NODES[1065](IS_STRUCTURE,0) = 1.000000; -NODES[1066](IS_STRUCTURE,0) = 1.000000; -NODES[1067](IS_STRUCTURE,0) = 1.000000; -NODES[1068](IS_STRUCTURE,0) = 1.000000; -NODES[1069](IS_STRUCTURE,0) = 1.000000; -NODES[1070](IS_STRUCTURE,0) = 1.000000; -NODES[1071](IS_STRUCTURE,0) = 1.000000; -NODES[1072](IS_STRUCTURE,0) = 1.000000; -NODES[1073](IS_STRUCTURE,0) = 1.000000; -NODES[1074](IS_STRUCTURE,0) = 1.000000; -NODES[1075](IS_STRUCTURE,0) = 1.000000; -NODES[1076](IS_STRUCTURE,0) = 1.000000; -NODES[1077](IS_STRUCTURE,0) = 1.000000; -NODES[1078](IS_STRUCTURE,0) = 1.000000; -NODES[1079](IS_STRUCTURE,0) = 1.000000; -NODES[1080](IS_STRUCTURE,0) = 1.000000; -NODES[1081](IS_STRUCTURE,0) = 1.000000; -NODES[1082](IS_STRUCTURE,0) = 1.000000; -NODES[1083](IS_STRUCTURE,0) = 1.000000; -NODES[1084](IS_STRUCTURE,0) = 1.000000; -NODES[1085](IS_STRUCTURE,0) = 1.000000; -NODES[1086](IS_STRUCTURE,0) = 1.000000; -NODES[1087](IS_STRUCTURE,0) = 1.000000; -NODES[1088](IS_STRUCTURE,0) = 1.000000; -NODES[1089](IS_STRUCTURE,0) = 1.000000; -NODES[1090](IS_STRUCTURE,0) = 1.000000; -NODES[1091](IS_STRUCTURE,0) = 1.000000; -NODES[1092](IS_STRUCTURE,0) = 1.000000; -NODES[1093](IS_STRUCTURE,0) = 1.000000; -NODES[1094](IS_STRUCTURE,0) = 1.000000; -NODES[1095](IS_STRUCTURE,0) = 1.000000; -NODES[1096](IS_STRUCTURE,0) = 1.000000; -NODES[1097](IS_STRUCTURE,0) = 1.000000; -NODES[1098](IS_STRUCTURE,0) = 1.000000; -NODES[1099](IS_STRUCTURE,0) = 1.000000; -NODES[1100](IS_STRUCTURE,0) = 1.000000; -NODES[1101](IS_STRUCTURE,0) = 1.000000; -NODES[1102](IS_STRUCTURE,0) = 1.000000; -NODES[1103](IS_STRUCTURE,0) = 1.000000; -NODES[1104](IS_STRUCTURE,0) = 1.000000; -NODES[1105](IS_STRUCTURE,0) = 1.000000; -NODES[1106](IS_STRUCTURE,0) = 1.000000; -NODES[1107](IS_STRUCTURE,0) = 1.000000; -NODES[1108](IS_STRUCTURE,0) = 1.000000; -NODES[1109](IS_STRUCTURE,0) = 1.000000; -NODES[1110](IS_STRUCTURE,0) = 1.000000; -NODES[1111](IS_STRUCTURE,0) = 1.000000; -NODES[1112](IS_STRUCTURE,0) = 1.000000; -NODES[1113](IS_STRUCTURE,0) = 1.000000; -NODES[1114](IS_STRUCTURE,0) = 1.000000; -NODES[1115](IS_STRUCTURE,0) = 1.000000; -NODES[1116](IS_STRUCTURE,0) = 1.000000; -NODES[1117](IS_STRUCTURE,0) = 1.000000; -NODES[1118](IS_STRUCTURE,0) = 1.000000; -NODES[1119](IS_STRUCTURE,0) = 1.000000; -NODES[1120](IS_STRUCTURE,0) = 1.000000; -NODES[1121](IS_STRUCTURE,0) = 1.000000; -NODES[1122](IS_STRUCTURE,0) = 1.000000; -NODES[1123](IS_STRUCTURE,0) = 1.000000; -NODES[1124](IS_STRUCTURE,0) = 1.000000; -NODES[1125](IS_STRUCTURE,0) = 1.000000; -NODES[1126](IS_STRUCTURE,0) = 1.000000; -NODES[1127](IS_STRUCTURE,0) = 1.000000; -NODES[1128](IS_STRUCTURE,0) = 1.000000; -NODES[1129](IS_STRUCTURE,0) = 1.000000; -NODES[1130](IS_STRUCTURE,0) = 1.000000; -NODES[1131](IS_STRUCTURE,0) = 1.000000; -NODES[1132](IS_STRUCTURE,0) = 1.000000; -NODES[1133](IS_STRUCTURE,0) = 1.000000; -NODES[1134](IS_STRUCTURE,0) = 1.000000; -NODES[1135](IS_STRUCTURE,0) = 1.000000; -NODES[1136](IS_STRUCTURE,0) = 1.000000; -NODES[1137](IS_STRUCTURE,0) = 1.000000; -NODES[1138](IS_STRUCTURE,0) = 1.000000; -NODES[1139](IS_STRUCTURE,0) = 1.000000; -NODES[1140](IS_STRUCTURE,0) = 1.000000; -NODES[1141](IS_STRUCTURE,0) = 1.000000; -NODES[1142](IS_STRUCTURE,0) = 1.000000; -NODES[1143](IS_STRUCTURE,0) = 1.000000; -NODES[1144](IS_STRUCTURE,0) = 1.000000; -NODES[1145](IS_STRUCTURE,0) = 1.000000; -NODES[1146](IS_STRUCTURE,0) = 1.000000; -NODES[1147](IS_STRUCTURE,0) = 1.000000; -NODES[1148](IS_STRUCTURE,0) = 1.000000; -NODES[1149](IS_STRUCTURE,0) = 1.000000; -NODES[1150](IS_STRUCTURE,0) = 1.000000; -NODES[1151](IS_STRUCTURE,0) = 1.000000; -NODES[1152](IS_STRUCTURE,0) = 1.000000; -NODES[1153](IS_STRUCTURE,0) = 1.000000; -NODES[1154](IS_STRUCTURE,0) = 1.000000; -NODES[1155](IS_STRUCTURE,0) = 1.000000; -NODES[1156](IS_STRUCTURE,0) = 1.000000; -NODES[1157](IS_STRUCTURE,0) = 1.000000; -NODES[1158](IS_STRUCTURE,0) = 1.000000; -NODES[1159](IS_STRUCTURE,0) = 1.000000; -NODES[1160](IS_STRUCTURE,0) = 1.000000; -NODES[1161](IS_STRUCTURE,0) = 1.000000; -NODES[1162](IS_STRUCTURE,0) = 1.000000; -NODES[1163](IS_STRUCTURE,0) = 1.000000; -NODES[1164](IS_STRUCTURE,0) = 1.000000; -NODES[1165](IS_STRUCTURE,0) = 1.000000; -NODES[1166](IS_STRUCTURE,0) = 1.000000; -NODES[1167](IS_STRUCTURE,0) = 1.000000; -NODES[1168](IS_STRUCTURE,0) = 1.000000; -NODES[1169](IS_STRUCTURE,0) = 1.000000; -NODES[1170](IS_STRUCTURE,0) = 1.000000; -NODES[1171](IS_STRUCTURE,0) = 1.000000; -NODES[1172](IS_STRUCTURE,0) = 1.000000; -NODES[1173](IS_STRUCTURE,0) = 1.000000; -NODES[1174](IS_STRUCTURE,0) = 1.000000; -NODES[1175](IS_STRUCTURE,0) = 1.000000; -NODES[1176](IS_STRUCTURE,0) = 1.000000; -NODES[1177](IS_STRUCTURE,0) = 1.000000; -NODES[1178](IS_STRUCTURE,0) = 1.000000; -NODES[1179](IS_STRUCTURE,0) = 1.000000; -NODES[1180](IS_STRUCTURE,0) = 1.000000; -NODES[1181](IS_STRUCTURE,0) = 1.000000; -NODES[1182](IS_STRUCTURE,0) = 1.000000; -NODES[1183](IS_STRUCTURE,0) = 1.000000; -NODES[1184](IS_STRUCTURE,0) = 1.000000; -NODES[1185](IS_STRUCTURE,0) = 1.000000; -NODES[1186](IS_STRUCTURE,0) = 1.000000; -NODES[1187](IS_STRUCTURE,0) = 1.000000; -NODES[1188](IS_STRUCTURE,0) = 1.000000; -NODES[1189](IS_STRUCTURE,0) = 1.000000; -NODES[1190](IS_STRUCTURE,0) = 1.000000; -NODES[1191](IS_STRUCTURE,0) = 1.000000; -NODES[1192](IS_STRUCTURE,0) = 1.000000; -NODES[1193](IS_STRUCTURE,0) = 1.000000; -NODES[1194](IS_STRUCTURE,0) = 1.000000; -NODES[1195](IS_STRUCTURE,0) = 1.000000; -NODES[1196](IS_STRUCTURE,0) = 1.000000; -NODES[1197](IS_STRUCTURE,0) = 1.000000; -NODES[1198](IS_STRUCTURE,0) = 1.000000; -NODES[1199](IS_STRUCTURE,0) = 1.000000; -NODES[1200](IS_STRUCTURE,0) = 1.000000; -NODES[1201](IS_STRUCTURE,0) = 1.000000; -NODES[1202](IS_STRUCTURE,0) = 1.000000; -NODES[1203](IS_STRUCTURE,0) = 1.000000; -NODES[1204](IS_STRUCTURE,0) = 1.000000; -NODES[1205](IS_STRUCTURE,0) = 1.000000; -NODES[1206](IS_STRUCTURE,0) = 1.000000; -NODES[1207](IS_STRUCTURE,0) = 1.000000; -NODES[1208](IS_STRUCTURE,0) = 1.000000; -NODES[1209](IS_STRUCTURE,0) = 1.000000; -NODES[1210](IS_STRUCTURE,0) = 1.000000; -NODES[1211](IS_STRUCTURE,0) = 1.000000; -NODES[1212](IS_STRUCTURE,0) = 1.000000; -NODES[1213](IS_STRUCTURE,0) = 1.000000; -NODES[1214](IS_STRUCTURE,0) = 1.000000; -NODES[1215](IS_STRUCTURE,0) = 1.000000; -NODES[1216](IS_STRUCTURE,0) = 1.000000; -NODES[1217](IS_STRUCTURE,0) = 1.000000; -NODES[1218](IS_STRUCTURE,0) = 1.000000; -NODES[1219](IS_STRUCTURE,0) = 1.000000; -NODES[1220](IS_STRUCTURE,0) = 1.000000; -NODES[1221](IS_STRUCTURE,0) = 1.000000; -NODES[1222](IS_STRUCTURE,0) = 1.000000; -NODES[1223](IS_STRUCTURE,0) = 1.000000; -NODES[1224](IS_STRUCTURE,0) = 1.000000; -NODES[1225](IS_STRUCTURE,0) = 1.000000; -NODES[1226](IS_STRUCTURE,0) = 1.000000; -NODES[1227](IS_STRUCTURE,0) = 1.000000; -NODES[1228](IS_STRUCTURE,0) = 1.000000; -NODES[1229](IS_STRUCTURE,0) = 1.000000; -NODES[1230](IS_STRUCTURE,0) = 1.000000; -NODES[1231](IS_STRUCTURE,0) = 1.000000; -NODES[1232](IS_STRUCTURE,0) = 1.000000; -NODES[1233](IS_STRUCTURE,0) = 1.000000; -NODES[1234](IS_STRUCTURE,0) = 1.000000; -NODES[1235](IS_STRUCTURE,0) = 1.000000; -NODES[1236](IS_STRUCTURE,0) = 1.000000; -NODES[1237](IS_STRUCTURE,0) = 1.000000; -NODES[1238](IS_STRUCTURE,0) = 1.000000; -NODES[1239](IS_STRUCTURE,0) = 1.000000; -NODES[1240](IS_STRUCTURE,0) = 1.000000; -NODES[1241](IS_STRUCTURE,0) = 1.000000; -NODES[1242](IS_STRUCTURE,0) = 1.000000; -NODES[1243](IS_STRUCTURE,0) = 1.000000; -NODES[1244](IS_STRUCTURE,0) = 1.000000; -NODES[1245](IS_STRUCTURE,0) = 1.000000; -NODES[1246](IS_STRUCTURE,0) = 1.000000; -NODES[1247](IS_STRUCTURE,0) = 1.000000; -NODES[1248](IS_STRUCTURE,0) = 1.000000; -NODES[1249](IS_STRUCTURE,0) = 1.000000; -NODES[1250](IS_STRUCTURE,0) = 1.000000; -NODES[1251](IS_STRUCTURE,0) = 1.000000; -NODES[1252](IS_STRUCTURE,0) = 1.000000; -NODES[1253](IS_STRUCTURE,0) = 1.000000; -NODES[1254](IS_STRUCTURE,0) = 1.000000; -NODES[1255](IS_STRUCTURE,0) = 1.000000; -NODES[1256](IS_STRUCTURE,0) = 1.000000; -NODES[1257](IS_STRUCTURE,0) = 1.000000; -NODES[1258](IS_STRUCTURE,0) = 1.000000; -NODES[1259](IS_STRUCTURE,0) = 1.000000; -NODES[1260](IS_STRUCTURE,0) = 1.000000; -NODES[1261](IS_STRUCTURE,0) = 1.000000; -NODES[1262](IS_STRUCTURE,0) = 1.000000; -NODES[1263](IS_STRUCTURE,0) = 1.000000; -NODES[1264](IS_STRUCTURE,0) = 1.000000; -NODES[1265](IS_STRUCTURE,0) = 1.000000; -NODES[1266](IS_STRUCTURE,0) = 1.000000; -NODES[1267](IS_STRUCTURE,0) = 1.000000; -NODES[1268](IS_STRUCTURE,0) = 1.000000; -NODES[1269](IS_STRUCTURE,0) = 1.000000; -NODES[1270](IS_STRUCTURE,0) = 1.000000; -NODES[1271](IS_STRUCTURE,0) = 1.000000; -NODES[1272](IS_STRUCTURE,0) = 1.000000; -NODES[1273](IS_STRUCTURE,0) = 1.000000; -NODES[1274](IS_STRUCTURE,0) = 1.000000; -NODES[1275](IS_STRUCTURE,0) = 1.000000; -NODES[1276](IS_STRUCTURE,0) = 1.000000; -NODES[1277](IS_STRUCTURE,0) = 1.000000; -NODES[1278](IS_STRUCTURE,0) = 1.000000; -NODES[1279](IS_STRUCTURE,0) = 1.000000; -NODES[1280](IS_STRUCTURE,0) = 1.000000; -NODES[1281](IS_STRUCTURE,0) = 1.000000; -NODES[1282](IS_STRUCTURE,0) = 1.000000; -NODES[1283](IS_STRUCTURE,0) = 1.000000; -NODES[1284](IS_STRUCTURE,0) = 1.000000; -NODES[1285](IS_STRUCTURE,0) = 1.000000; -NODES[1286](IS_STRUCTURE,0) = 1.000000; -NODES[1287](IS_STRUCTURE,0) = 1.000000; -NODES[1288](IS_STRUCTURE,0) = 1.000000; -NODES[1289](IS_STRUCTURE,0) = 1.000000; -NODES[1290](IS_STRUCTURE,0) = 1.000000; -NODES[1291](IS_STRUCTURE,0) = 1.000000; -NODES[1292](IS_STRUCTURE,0) = 1.000000; -NODES[1293](IS_STRUCTURE,0) = 1.000000; -NODES[1294](IS_STRUCTURE,0) = 1.000000; -NODES[1295](IS_STRUCTURE,0) = 1.000000; -NODES[1296](IS_STRUCTURE,0) = 1.000000; -NODES[1297](IS_STRUCTURE,0) = 1.000000; -NODES[1298](IS_STRUCTURE,0) = 1.000000; -NODES[1299](IS_STRUCTURE,0) = 1.000000; -NODES[1300](IS_STRUCTURE,0) = 1.000000; -NODES[1301](IS_STRUCTURE,0) = 1.000000; -NODES[1302](IS_STRUCTURE,0) = 1.000000; -NODES[1303](IS_STRUCTURE,0) = 1.000000; -NODES[1304](IS_STRUCTURE,0) = 1.000000; -NODES[1305](IS_STRUCTURE,0) = 1.000000; -NODES[1306](IS_STRUCTURE,0) = 1.000000; -NODES[1307](IS_STRUCTURE,0) = 1.000000; -NODES[1308](IS_STRUCTURE,0) = 1.000000; -NODES[1309](IS_STRUCTURE,0) = 1.000000; -NODES[1310](IS_STRUCTURE,0) = 1.000000; -NODES[1311](IS_STRUCTURE,0) = 1.000000; -NODES[1312](IS_STRUCTURE,0) = 1.000000; -NODES[1313](IS_STRUCTURE,0) = 1.000000; -NODES[1314](IS_STRUCTURE,0) = 1.000000; -NODES[1315](IS_STRUCTURE,0) = 1.000000; -NODES[1316](IS_STRUCTURE,0) = 1.000000; -NODES[1317](IS_STRUCTURE,0) = 1.000000; -NODES[1318](IS_STRUCTURE,0) = 1.000000; -NODES[1319](IS_STRUCTURE,0) = 1.000000; -NODES[1320](IS_STRUCTURE,0) = 1.000000; -NODES[1321](IS_STRUCTURE,0) = 1.000000; -NODES[1322](IS_STRUCTURE,0) = 1.000000; -NODES[1323](IS_STRUCTURE,0) = 1.000000; -NODES[1324](IS_STRUCTURE,0) = 1.000000; -NODES[1325](IS_STRUCTURE,0) = 1.000000; -NODES[1326](IS_STRUCTURE,0) = 1.000000; -NODES[1327](IS_STRUCTURE,0) = 1.000000; -NODES[1328](IS_STRUCTURE,0) = 1.000000; -NODES[1329](IS_STRUCTURE,0) = 1.000000; -NODES[1330](IS_STRUCTURE,0) = 1.000000; -NODES[1331](IS_STRUCTURE,0) = 1.000000; -NODES[1332](IS_STRUCTURE,0) = 1.000000; -NODES[1333](IS_STRUCTURE,0) = 1.000000; -NODES[1334](IS_STRUCTURE,0) = 1.000000; -NODES[1335](IS_STRUCTURE,0) = 1.000000; -NODES[1336](IS_STRUCTURE,0) = 1.000000; -NODES[1337](IS_STRUCTURE,0) = 1.000000; -NODES[1338](IS_STRUCTURE,0) = 1.000000; -NODES[1339](IS_STRUCTURE,0) = 1.000000; -NODES[1340](IS_STRUCTURE,0) = 1.000000; -NODES[1341](IS_STRUCTURE,0) = 1.000000; -NODES[1342](IS_STRUCTURE,0) = 1.000000; -NODES[1343](IS_STRUCTURE,0) = 1.000000; -NODES[1344](IS_STRUCTURE,0) = 1.000000; -NODES[1345](IS_STRUCTURE,0) = 1.000000; -NODES[1346](IS_STRUCTURE,0) = 1.000000; -NODES[1347](IS_STRUCTURE,0) = 1.000000; -NODES[1348](IS_STRUCTURE,0) = 1.000000; -NODES[1349](IS_STRUCTURE,0) = 1.000000; -NODES[1350](IS_STRUCTURE,0) = 1.000000; -NODES[1351](IS_STRUCTURE,0) = 1.000000; -NODES[1352](IS_STRUCTURE,0) = 1.000000; -NODES[1353](IS_STRUCTURE,0) = 1.000000; -NODES[1354](IS_STRUCTURE,0) = 1.000000; -NODES[1355](IS_STRUCTURE,0) = 1.000000; -NODES[1356](IS_STRUCTURE,0) = 1.000000; -NODES[1357](IS_STRUCTURE,0) = 1.000000; -NODES[1358](IS_STRUCTURE,0) = 1.000000; -NODES[1359](IS_STRUCTURE,0) = 1.000000; -NODES[1360](IS_STRUCTURE,0) = 1.000000; -NODES[1361](IS_STRUCTURE,0) = 1.000000; -NODES[1362](IS_STRUCTURE,0) = 1.000000; -NODES[1363](IS_STRUCTURE,0) = 1.000000; -NODES[1364](IS_STRUCTURE,0) = 1.000000; -NODES[1365](IS_STRUCTURE,0) = 1.000000; -NODES[1366](IS_STRUCTURE,0) = 1.000000; -NODES[1367](IS_STRUCTURE,0) = 1.000000; -NODES[1368](IS_STRUCTURE,0) = 1.000000; -NODES[1369](IS_STRUCTURE,0) = 1.000000; -NODES[1370](IS_STRUCTURE,0) = 1.000000; -NODES[1371](IS_STRUCTURE,0) = 1.000000; -NODES[1372](IS_STRUCTURE,0) = 1.000000; -NODES[1373](IS_STRUCTURE,0) = 1.000000; -NODES[1374](IS_STRUCTURE,0) = 1.000000; -NODES[1375](IS_STRUCTURE,0) = 1.000000; -NODES[1376](IS_STRUCTURE,0) = 1.000000; -NODES[1377](IS_STRUCTURE,0) = 1.000000; -NODES[1378](IS_STRUCTURE,0) = 1.000000; -NODES[1379](IS_STRUCTURE,0) = 1.000000; -NODES[1380](IS_STRUCTURE,0) = 1.000000; -NODES[1381](IS_STRUCTURE,0) = 1.000000; -NODES[1382](IS_STRUCTURE,0) = 1.000000; -NODES[1383](IS_STRUCTURE,0) = 1.000000; -NODES[1384](IS_STRUCTURE,0) = 1.000000; -NODES[1385](IS_STRUCTURE,0) = 1.000000; -NODES[1386](IS_STRUCTURE,0) = 1.000000; -NODES[1387](IS_STRUCTURE,0) = 1.000000; -NODES[1388](IS_STRUCTURE,0) = 1.000000; -NODES[1389](IS_STRUCTURE,0) = 1.000000; -NODES[1390](IS_STRUCTURE,0) = 1.000000; -NODES[1391](IS_STRUCTURE,0) = 1.000000; -NODES[1392](IS_STRUCTURE,0) = 1.000000; -NODES[1393](IS_STRUCTURE,0) = 1.000000; -NODES[1394](IS_STRUCTURE,0) = 1.000000; -NODES[1395](IS_STRUCTURE,0) = 1.000000; -NODES[1396](IS_STRUCTURE,0) = 1.000000; -NODES[1397](IS_STRUCTURE,0) = 1.000000; -NODES[1398](IS_STRUCTURE,0) = 1.000000; -NODES[1399](IS_STRUCTURE,0) = 1.000000; -NODES[1400](IS_STRUCTURE,0) = 1.000000; -NODES[1401](IS_STRUCTURE,0) = 1.000000; -NODES[1402](IS_STRUCTURE,0) = 1.000000; -NODES[1403](IS_STRUCTURE,0) = 1.000000; -NODES[1404](IS_STRUCTURE,0) = 1.000000; -NODES[1405](IS_STRUCTURE,0) = 1.000000; -NODES[1406](IS_STRUCTURE,0) = 1.000000; -NODES[1407](IS_STRUCTURE,0) = 1.000000; -NODES[1408](IS_STRUCTURE,0) = 1.000000; -NODES[1409](IS_STRUCTURE,0) = 1.000000; -NODES[1410](IS_STRUCTURE,0) = 1.000000; -NODES[1411](IS_STRUCTURE,0) = 1.000000; -NODES[1412](IS_STRUCTURE,0) = 1.000000; -NODES[1413](IS_STRUCTURE,0) = 1.000000; -NODES[1414](IS_STRUCTURE,0) = 1.000000; -NODES[1415](IS_STRUCTURE,0) = 1.000000; -NODES[1416](IS_STRUCTURE,0) = 1.000000; -NODES[1417](IS_STRUCTURE,0) = 1.000000; -NODES[1418](IS_STRUCTURE,0) = 1.000000; -NODES[1419](IS_STRUCTURE,0) = 1.000000; -NODES[1420](IS_STRUCTURE,0) = 1.000000; -NODES[1421](IS_STRUCTURE,0) = 1.000000; -NODES[1422](IS_STRUCTURE,0) = 1.000000; -NODES[1423](IS_STRUCTURE,0) = 1.000000; -NODES[1424](IS_STRUCTURE,0) = 1.000000; -NODES[1425](IS_STRUCTURE,0) = 1.000000; -NODES[1426](IS_STRUCTURE,0) = 1.000000; -NODES[1427](IS_STRUCTURE,0) = 1.000000; -NODES[1428](IS_STRUCTURE,0) = 1.000000; -NODES[1429](IS_STRUCTURE,0) = 1.000000; -NODES[1430](IS_STRUCTURE,0) = 1.000000; -NODES[1431](IS_STRUCTURE,0) = 1.000000; -NODES[1432](IS_STRUCTURE,0) = 1.000000; -NODES[1433](IS_STRUCTURE,0) = 1.000000; -NODES[1434](IS_STRUCTURE,0) = 1.000000; -NODES[1435](IS_STRUCTURE,0) = 1.000000; -NODES[1436](IS_STRUCTURE,0) = 1.000000; -NODES[1437](IS_STRUCTURE,0) = 1.000000; -NODES[1438](IS_STRUCTURE,0) = 1.000000; -NODES[1439](IS_STRUCTURE,0) = 1.000000; -NODES[1440](IS_STRUCTURE,0) = 1.000000; -NODES[1441](IS_STRUCTURE,0) = 1.000000; -NODES[1442](IS_STRUCTURE,0) = 1.000000; -NODES[1443](IS_STRUCTURE,0) = 1.000000; -NODES[1444](IS_STRUCTURE,0) = 1.000000; -NODES[1445](IS_STRUCTURE,0) = 1.000000; -NODES[1446](IS_STRUCTURE,0) = 1.000000; -NODES[1447](IS_STRUCTURE,0) = 1.000000; -NODES[1448](IS_STRUCTURE,0) = 1.000000; -NODES[1449](IS_STRUCTURE,0) = 1.000000; -NODES[1450](IS_STRUCTURE,0) = 1.000000; -NODES[1451](IS_STRUCTURE,0) = 1.000000; -NODES[1452](IS_STRUCTURE,0) = 1.000000; -NODES[1453](IS_STRUCTURE,0) = 1.000000; -NODES[1454](IS_STRUCTURE,0) = 1.000000; -NODES[1455](IS_STRUCTURE,0) = 1.000000; -NODES[1456](IS_STRUCTURE,0) = 1.000000; -NODES[1457](IS_STRUCTURE,0) = 1.000000; -NODES[1458](IS_STRUCTURE,0) = 1.000000; -NODES[1459](IS_STRUCTURE,0) = 1.000000; -NODES[1460](IS_STRUCTURE,0) = 1.000000; -NODES[1461](IS_STRUCTURE,0) = 1.000000; -NODES[1462](IS_STRUCTURE,0) = 1.000000; -NODES[1463](IS_STRUCTURE,0) = 1.000000; -NODES[1464](IS_STRUCTURE,0) = 1.000000; -NODES[1465](IS_STRUCTURE,0) = 1.000000; -NODES[1466](IS_STRUCTURE,0) = 1.000000; -NODES[1467](IS_STRUCTURE,0) = 1.000000; -NODES[1468](IS_STRUCTURE,0) = 1.000000; -NODES[1469](IS_STRUCTURE,0) = 1.000000; -NODES[1470](IS_STRUCTURE,0) = 1.000000; -NODES[1471](IS_STRUCTURE,0) = 1.000000; -NODES[1472](IS_STRUCTURE,0) = 1.000000; -NODES[1473](IS_STRUCTURE,0) = 1.000000; -NODES[1474](IS_STRUCTURE,0) = 1.000000; -NODES[1475](IS_STRUCTURE,0) = 1.000000; -NODES[1476](IS_STRUCTURE,0) = 1.000000; -NODES[1477](IS_STRUCTURE,0) = 1.000000; -NODES[1478](IS_STRUCTURE,0) = 1.000000; -NODES[1479](IS_STRUCTURE,0) = 1.000000; -NODES[1480](IS_STRUCTURE,0) = 1.000000; -NODES[1481](IS_STRUCTURE,0) = 1.000000; -NODES[1482](IS_STRUCTURE,0) = 1.000000; -NODES[1483](IS_STRUCTURE,0) = 1.000000; -NODES[1484](IS_STRUCTURE,0) = 1.000000; -NODES[1485](IS_STRUCTURE,0) = 1.000000; -NODES[1486](IS_STRUCTURE,0) = 1.000000; -NODES[1487](IS_STRUCTURE,0) = 1.000000; -NODES[1488](IS_STRUCTURE,0) = 1.000000; -NODES[1489](IS_STRUCTURE,0) = 1.000000; -NODES[1490](IS_STRUCTURE,0) = 1.000000; -NODES[1491](IS_STRUCTURE,0) = 1.000000; -NODES[1492](IS_STRUCTURE,0) = 1.000000; -NODES[1493](IS_STRUCTURE,0) = 1.000000; -NODES[1494](IS_STRUCTURE,0) = 1.000000; -NODES[1495](IS_STRUCTURE,0) = 1.000000; -NODES[1496](IS_STRUCTURE,0) = 1.000000; -NODES[1497](IS_STRUCTURE,0) = 1.000000; -NODES[1498](IS_STRUCTURE,0) = 1.000000; -NODES[1499](IS_STRUCTURE,0) = 1.000000; -NODES[1500](IS_STRUCTURE,0) = 1.000000; -NODES[1501](IS_STRUCTURE,0) = 1.000000; -NODES[1502](IS_STRUCTURE,0) = 1.000000; -NODES[1503](IS_STRUCTURE,0) = 1.000000; -NODES[1504](IS_STRUCTURE,0) = 1.000000; -NODES[1505](IS_STRUCTURE,0) = 1.000000; -NODES[1506](IS_STRUCTURE,0) = 1.000000; -NODES[1507](IS_STRUCTURE,0) = 1.000000; -NODES[1508](IS_STRUCTURE,0) = 1.000000; -NODES[1509](IS_STRUCTURE,0) = 1.000000; -NODES[1510](IS_STRUCTURE,0) = 1.000000; -NODES[1511](IS_STRUCTURE,0) = 1.000000; -NODES[1512](IS_STRUCTURE,0) = 1.000000; -NODES[1513](IS_STRUCTURE,0) = 1.000000; -NODES[1514](IS_STRUCTURE,0) = 1.000000; -NODES[1515](IS_STRUCTURE,0) = 1.000000; -NODES[1516](IS_STRUCTURE,0) = 1.000000; -NODES[1517](IS_STRUCTURE,0) = 1.000000; -NODES[1518](IS_STRUCTURE,0) = 1.000000; -NODES[1519](IS_STRUCTURE,0) = 1.000000; -NODES[1520](IS_STRUCTURE,0) = 1.000000; -NODES[1521](IS_STRUCTURE,0) = 1.000000; -NODES[1522](IS_STRUCTURE,0) = 1.000000; -NODES[1523](IS_STRUCTURE,0) = 1.000000; -NODES[1524](IS_STRUCTURE,0) = 1.000000; -NODES[1525](IS_STRUCTURE,0) = 1.000000; -NODES[1526](IS_STRUCTURE,0) = 1.000000; -NODES[1527](IS_STRUCTURE,0) = 1.000000; -NODES[1528](IS_STRUCTURE,0) = 1.000000; -NODES[1529](IS_STRUCTURE,0) = 1.000000; -NODES[1530](IS_STRUCTURE,0) = 1.000000; -NODES[1531](IS_STRUCTURE,0) = 1.000000; -NODES[1532](IS_STRUCTURE,0) = 1.000000; -NODES[1533](IS_STRUCTURE,0) = 1.000000; -NODES[1534](IS_STRUCTURE,0) = 1.000000; -NODES[1535](IS_STRUCTURE,0) = 1.000000; -NODES[1536](IS_STRUCTURE,0) = 1.000000; -NODES[1537](IS_STRUCTURE,0) = 1.000000; -NODES[1538](IS_STRUCTURE,0) = 1.000000; -NODES[1539](IS_STRUCTURE,0) = 1.000000; -NODES[1540](IS_STRUCTURE,0) = 1.000000; -NODES[1541](IS_STRUCTURE,0) = 1.000000; -NODES[1542](IS_STRUCTURE,0) = 1.000000; -NODES[1544](IS_STRUCTURE,0) = 1.000000; -NODES[1545](IS_STRUCTURE,0) = 1.000000; -NODES[1547](IS_STRUCTURE,0) = 1.000000; -NODES[1548](IS_STRUCTURE,0) = 1.000000; -NODES[1549](IS_STRUCTURE,0) = 1.000000; -NODES[1550](IS_STRUCTURE,0) = 1.000000; -NODES[1551](IS_STRUCTURE,0) = 1.000000; -NODES[1552](IS_STRUCTURE,0) = 1.000000; -NODES[1554](IS_STRUCTURE,0) = 1.000000; -NODES[1555](IS_STRUCTURE,0) = 1.000000; -NODES[1556](IS_STRUCTURE,0) = 1.000000; -NODES[1557](IS_STRUCTURE,0) = 1.000000; -NODES[1558](IS_STRUCTURE,0) = 1.000000; -NODES[1559](IS_STRUCTURE,0) = 1.000000; -NODES[1560](IS_STRUCTURE,0) = 1.000000; -NODES[1561](IS_STRUCTURE,0) = 1.000000; -NODES[1562](IS_STRUCTURE,0) = 1.000000; -NODES[1564](IS_STRUCTURE,0) = 1.000000; -NODES[1565](IS_STRUCTURE,0) = 1.000000; -NODES[1566](IS_STRUCTURE,0) = 1.000000; -NODES[1567](IS_STRUCTURE,0) = 1.000000; -NODES[1568](IS_STRUCTURE,0) = 1.000000; -NODES[1569](IS_STRUCTURE,0) = 1.000000; -NODES[1570](IS_STRUCTURE,0) = 1.000000; -NODES[1571](IS_STRUCTURE,0) = 1.000000; -NODES[1572](IS_STRUCTURE,0) = 1.000000; -NODES[1573](IS_STRUCTURE,0) = 1.000000; -NODES[1574](IS_STRUCTURE,0) = 1.000000; -NODES[1576](IS_STRUCTURE,0) = 1.000000; -NODES[1577](IS_STRUCTURE,0) = 1.000000; -NODES[1578](IS_STRUCTURE,0) = 1.000000; -NODES[1579](IS_STRUCTURE,0) = 1.000000; -NODES[1580](IS_STRUCTURE,0) = 1.000000; -NODES[1581](IS_STRUCTURE,0) = 1.000000; -NODES[1582](IS_STRUCTURE,0) = 1.000000; -NODES[1583](IS_STRUCTURE,0) = 1.000000; -NODES[1584](IS_STRUCTURE,0) = 1.000000; -NODES[1585](IS_STRUCTURE,0) = 1.000000; -NODES[1586](IS_STRUCTURE,0) = 1.000000; -NODES[1587](IS_STRUCTURE,0) = 1.000000; -NODES[1588](IS_STRUCTURE,0) = 1.000000; -NODES[1589](IS_STRUCTURE,0) = 1.000000; -NODES[1590](IS_STRUCTURE,0) = 1.000000; -NODES[1591](IS_STRUCTURE,0) = 1.000000; -NODES[1592](IS_STRUCTURE,0) = 1.000000; -NODES[1594](IS_STRUCTURE,0) = 1.000000; -NODES[1595](IS_STRUCTURE,0) = 1.000000; -NODES[1596](IS_STRUCTURE,0) = 1.000000; -NODES[1597](IS_STRUCTURE,0) = 1.000000; -NODES[1598](IS_STRUCTURE,0) = 1.000000; -NODES[1599](IS_STRUCTURE,0) = 1.000000; -NODES[1600](IS_STRUCTURE,0) = 1.000000; -NODES[1601](IS_STRUCTURE,0) = 1.000000; -NODES[1602](IS_STRUCTURE,0) = 1.000000; -NODES[1603](IS_STRUCTURE,0) = 1.000000; -NODES[1604](IS_STRUCTURE,0) = 1.000000; -NODES[1605](IS_STRUCTURE,0) = 1.000000; -NODES[1607](IS_STRUCTURE,0) = 1.000000; -NODES[1608](IS_STRUCTURE,0) = 1.000000; -NODES[1609](IS_STRUCTURE,0) = 1.000000; -NODES[1611](IS_STRUCTURE,0) = 1.000000; -NODES[1612](IS_STRUCTURE,0) = 1.000000; -NODES[1614](IS_STRUCTURE,0) = 1.000000; -NODES[1615](IS_STRUCTURE,0) = 1.000000; -NODES[1617](IS_STRUCTURE,0) = 1.000000; -NODES[1619](IS_STRUCTURE,0) = 1.000000; -NODES[1620](IS_STRUCTURE,0) = 1.000000; -NODES[1622](IS_STRUCTURE,0) = 1.000000; -NODES[1623](IS_STRUCTURE,0) = 1.000000; -NODES[1624](IS_STRUCTURE,0) = 1.000000; -NODES[1626](IS_STRUCTURE,0) = 1.000000; -NODES[1627](IS_STRUCTURE,0) = 1.000000; -NODES[1628](IS_STRUCTURE,0) = 1.000000; -NODES[1629](IS_STRUCTURE,0) = 1.000000; -NODES[1630](IS_STRUCTURE,0) = 1.000000; -NODES[1631](IS_STRUCTURE,0) = 1.000000; -NODES[1632](IS_STRUCTURE,0) = 1.000000; -NODES[1633](IS_STRUCTURE,0) = 1.000000; -NODES[1634](IS_STRUCTURE,0) = 1.000000; -NODES[1635](IS_STRUCTURE,0) = 1.000000; -NODES[1636](IS_STRUCTURE,0) = 1.000000; -NODES[1637](IS_STRUCTURE,0) = 1.000000; -NODES[1638](IS_STRUCTURE,0) = 1.000000; -NODES[1640](IS_STRUCTURE,0) = 1.000000; -NODES[1642](IS_STRUCTURE,0) = 1.000000; -NODES[1643](IS_STRUCTURE,0) = 1.000000; -NODES[1645](IS_STRUCTURE,0) = 1.000000; -NODES[1646](IS_STRUCTURE,0) = 1.000000; -NODES[1647](IS_STRUCTURE,0) = 1.000000; -NODES[1648](IS_STRUCTURE,0) = 1.000000; -NODES[1649](IS_STRUCTURE,0) = 1.000000; -NODES[1650](IS_STRUCTURE,0) = 1.000000; -NODES[1651](IS_STRUCTURE,0) = 1.000000; -NODES[1652](IS_STRUCTURE,0) = 1.000000; -NODES[1653](IS_STRUCTURE,0) = 1.000000; -NODES[1654](IS_STRUCTURE,0) = 1.000000; -NODES[1655](IS_STRUCTURE,0) = 1.000000; -NODES[1656](IS_STRUCTURE,0) = 1.000000; -NODES[1657](IS_STRUCTURE,0) = 1.000000; -NODES[1658](IS_STRUCTURE,0) = 1.000000; -NODES[1661](IS_STRUCTURE,0) = 1.000000; -NODES[1662](IS_STRUCTURE,0) = 1.000000; -NODES[1663](IS_STRUCTURE,0) = 1.000000; -NODES[1665](IS_STRUCTURE,0) = 1.000000; -NODES[1666](IS_STRUCTURE,0) = 1.000000; -NODES[1667](IS_STRUCTURE,0) = 1.000000; -NODES[1668](IS_STRUCTURE,0) = 1.000000; -NODES[1669](IS_STRUCTURE,0) = 1.000000; -NODES[1670](IS_STRUCTURE,0) = 1.000000; -NODES[1672](IS_STRUCTURE,0) = 1.000000; -NODES[1673](IS_STRUCTURE,0) = 1.000000; -NODES[1674](IS_STRUCTURE,0) = 1.000000; -NODES[1675](IS_STRUCTURE,0) = 1.000000; -NODES[1676](IS_STRUCTURE,0) = 1.000000; -NODES[1678](IS_STRUCTURE,0) = 1.000000; -NODES[1679](IS_STRUCTURE,0) = 1.000000; -NODES[1682](IS_STRUCTURE,0) = 1.000000; -NODES[1683](IS_STRUCTURE,0) = 1.000000; -NODES[1684](IS_STRUCTURE,0) = 1.000000; -NODES[1685](IS_STRUCTURE,0) = 1.000000; -NODES[1686](IS_STRUCTURE,0) = 1.000000; -NODES[1687](IS_STRUCTURE,0) = 1.000000; -NODES[1688](IS_STRUCTURE,0) = 1.000000; -NODES[1689](IS_STRUCTURE,0) = 1.000000; -NODES[1690](IS_STRUCTURE,0) = 1.000000; -NODES[1691](IS_STRUCTURE,0) = 1.000000; -NODES[1692](IS_STRUCTURE,0) = 1.000000; -NODES[1694](IS_STRUCTURE,0) = 1.000000; -NODES[1695](IS_STRUCTURE,0) = 1.000000; -NODES[1696](IS_STRUCTURE,0) = 1.000000; -NODES[1699](IS_STRUCTURE,0) = 1.000000; -NODES[1700](IS_STRUCTURE,0) = 1.000000; -NODES[1701](IS_STRUCTURE,0) = 1.000000; -NODES[1703](IS_STRUCTURE,0) = 1.000000; -NODES[1704](IS_STRUCTURE,0) = 1.000000; -NODES[1707](IS_STRUCTURE,0) = 1.000000; -NODES[1708](IS_STRUCTURE,0) = 1.000000; -NODES[1709](IS_STRUCTURE,0) = 1.000000; -NODES[1710](IS_STRUCTURE,0) = 1.000000; -NODES[1714](IS_STRUCTURE,0) = 1.000000; -NODES[1716](IS_STRUCTURE,0) = 1.000000; -NODES[1718](IS_STRUCTURE,0) = 1.000000; -NODES[1719](IS_STRUCTURE,0) = 1.000000; -NODES[1720](IS_STRUCTURE,0) = 1.000000; -NODES[1724](IS_STRUCTURE,0) = 1.000000; -NODES[1725](IS_STRUCTURE,0) = 1.000000; -NODES[1726](IS_STRUCTURE,0) = 1.000000; -NODES[1730](IS_STRUCTURE,0) = 1.000000; -NODES[1731](IS_STRUCTURE,0) = 1.000000; -NODES[1732](IS_STRUCTURE,0) = 1.000000; -NODES[1733](IS_STRUCTURE,0) = 1.000000; -NODES[1734](IS_STRUCTURE,0) = 1.000000; -NODES[1735](IS_STRUCTURE,0) = 1.000000; -NODES[1736](IS_STRUCTURE,0) = 1.000000; -NODES[1737](IS_STRUCTURE,0) = 1.000000; -NODES[1738](IS_STRUCTURE,0) = 1.000000; -NODES[1741](IS_STRUCTURE,0) = 1.000000; -NODES[1742](IS_STRUCTURE,0) = 1.000000; -NODES[1743](IS_STRUCTURE,0) = 1.000000; -NODES[1745](IS_STRUCTURE,0) = 1.000000; -NODES[1747](IS_STRUCTURE,0) = 1.000000; -NODES[1748](IS_STRUCTURE,0) = 1.000000; -NODES[1749](IS_STRUCTURE,0) = 1.000000; -NODES[1750](IS_STRUCTURE,0) = 1.000000; -NODES[1753](IS_STRUCTURE,0) = 1.000000; -NODES[1754](IS_STRUCTURE,0) = 1.000000; -NODES[1755](IS_STRUCTURE,0) = 1.000000; -NODES[1757](IS_STRUCTURE,0) = 1.000000; -NODES[1758](IS_STRUCTURE,0) = 1.000000; -NODES[1760](IS_STRUCTURE,0) = 1.000000; -NODES[1761](IS_STRUCTURE,0) = 1.000000; -NODES[1762](IS_STRUCTURE,0) = 1.000000; -NODES[1763](IS_STRUCTURE,0) = 1.000000; -NODES[1764](IS_STRUCTURE,0) = 1.000000; -NODES[1765](IS_STRUCTURE,0) = 1.000000; -NODES[1766](IS_STRUCTURE,0) = 1.000000; -NODES[1768](IS_STRUCTURE,0) = 1.000000; -NODES[1769](IS_STRUCTURE,0) = 1.000000; -NODES[1770](IS_STRUCTURE,0) = 1.000000; -NODES[1771](IS_STRUCTURE,0) = 1.000000; -NODES[1772](IS_STRUCTURE,0) = 1.000000; -NODES[1773](IS_STRUCTURE,0) = 1.000000; -NODES[1774](IS_STRUCTURE,0) = 1.000000; -NODES[1775](IS_STRUCTURE,0) = 1.000000; -NODES[1776](IS_STRUCTURE,0) = 1.000000; -NODES[1777](IS_STRUCTURE,0) = 1.000000; -NODES[1778](IS_STRUCTURE,0) = 1.000000; -NODES[1779](IS_STRUCTURE,0) = 1.000000; -NODES[1780](IS_STRUCTURE,0) = 1.000000; -NODES[1781](IS_STRUCTURE,0) = 1.000000; -NODES[1784](IS_STRUCTURE,0) = 1.000000; -NODES[1787](IS_STRUCTURE,0) = 1.000000; -NODES[1788](IS_STRUCTURE,0) = 1.000000; -NODES[1790](IS_STRUCTURE,0) = 1.000000; -NODES[1792](IS_STRUCTURE,0) = 1.000000; -NODES[1793](IS_STRUCTURE,0) = 1.000000; -NODES[1794](IS_STRUCTURE,0) = 1.000000; -NODES[1796](IS_STRUCTURE,0) = 1.000000; -NODES[1797](IS_STRUCTURE,0) = 1.000000; -NODES[1798](IS_STRUCTURE,0) = 1.000000; -NODES[1799](IS_STRUCTURE,0) = 1.000000; -NODES[1800](IS_STRUCTURE,0) = 1.000000; -NODES[1805](IS_STRUCTURE,0) = 1.000000; -NODES[1806](IS_STRUCTURE,0) = 1.000000; -NODES[1810](IS_STRUCTURE,0) = 1.000000; -NODES[1813](IS_STRUCTURE,0) = 1.000000; -NODES[1815](IS_STRUCTURE,0) = 1.000000; -NODES[1817](IS_STRUCTURE,0) = 1.000000; -NODES[1819](IS_STRUCTURE,0) = 1.000000; -NODES[1820](IS_STRUCTURE,0) = 1.000000; -NODES[1822](IS_STRUCTURE,0) = 1.000000; -NODES[1824](IS_STRUCTURE,0) = 1.000000; -NODES[1825](IS_STRUCTURE,0) = 1.000000; -NODES[1826](IS_STRUCTURE,0) = 1.000000; -NODES[1827](IS_STRUCTURE,0) = 1.000000; -NODES[1830](IS_STRUCTURE,0) = 1.000000; -NODES[1834](IS_STRUCTURE,0) = 1.000000; -NODES[1835](IS_STRUCTURE,0) = 1.000000; -NODES[1837](IS_STRUCTURE,0) = 1.000000; -NODES[1838](IS_STRUCTURE,0) = 1.000000; -NODES[1841](IS_STRUCTURE,0) = 1.000000; -NODES[1842](IS_STRUCTURE,0) = 1.000000; -NODES[1843](IS_STRUCTURE,0) = 1.000000; -NODES[1844](IS_STRUCTURE,0) = 1.000000; -NODES[1845](IS_STRUCTURE,0) = 1.000000; -NODES[1847](IS_STRUCTURE,0) = 1.000000; -NODES[1850](IS_STRUCTURE,0) = 1.000000; -NODES[1851](IS_STRUCTURE,0) = 1.000000; -NODES[1852](IS_STRUCTURE,0) = 1.000000; -NODES[1853](IS_STRUCTURE,0) = 1.000000; -NODES[1855](IS_STRUCTURE,0) = 1.000000; -NODES[1857](IS_STRUCTURE,0) = 1.000000; -NODES[1858](IS_STRUCTURE,0) = 1.000000; -NODES[1859](IS_STRUCTURE,0) = 1.000000; -NODES[1860](IS_STRUCTURE,0) = 1.000000; -NODES[1863](IS_STRUCTURE,0) = 1.000000; -NODES[1864](IS_STRUCTURE,0) = 1.000000; -NODES[1865](IS_STRUCTURE,0) = 1.000000; -NODES[1866](IS_STRUCTURE,0) = 1.000000; -NODES[1867](IS_STRUCTURE,0) = 1.000000; -NODES[1871](IS_STRUCTURE,0) = 1.000000; -NODES[1877](IS_STRUCTURE,0) = 1.000000; -NODES[1882](IS_STRUCTURE,0) = 1.000000; -NODES[1883](IS_STRUCTURE,0) = 1.000000; -NODES[1884](IS_STRUCTURE,0) = 1.000000; -NODES[1886](IS_STRUCTURE,0) = 1.000000; -NODES[1890](IS_STRUCTURE,0) = 1.000000; -NODES[1891](IS_STRUCTURE,0) = 1.000000; -NODES[1892](IS_STRUCTURE,0) = 1.000000; -NODES[1894](IS_STRUCTURE,0) = 1.000000; -NODES[1895](IS_STRUCTURE,0) = 1.000000; -NODES[1896](IS_STRUCTURE,0) = 1.000000; -NODES[1898](IS_STRUCTURE,0) = 1.000000; -NODES[1899](IS_STRUCTURE,0) = 1.000000; -NODES[1900](IS_STRUCTURE,0) = 1.000000; -NODES[1901](IS_STRUCTURE,0) = 1.000000; -NODES[1902](IS_STRUCTURE,0) = 1.000000; -NODES[1903](IS_STRUCTURE,0) = 1.000000; -NODES[1904](IS_STRUCTURE,0) = 1.000000; -NODES[1905](IS_STRUCTURE,0) = 1.000000; -NODES[1908](IS_STRUCTURE,0) = 1.000000; -NODES[1909](IS_STRUCTURE,0) = 1.000000; -NODES[1912](IS_STRUCTURE,0) = 1.000000; -NODES[1914](IS_STRUCTURE,0) = 1.000000; -NODES[1918](IS_STRUCTURE,0) = 1.000000; -NODES[1920](IS_STRUCTURE,0) = 1.000000; -NODES[1921](IS_STRUCTURE,0) = 1.000000; -NODES[1923](IS_STRUCTURE,0) = 1.000000; -NODES[1925](IS_STRUCTURE,0) = 1.000000; -NODES[1926](IS_STRUCTURE,0) = 1.000000; -NODES[1927](IS_STRUCTURE,0) = 1.000000; -NODES[1929](IS_STRUCTURE,0) = 1.000000; -NODES[1930](IS_STRUCTURE,0) = 1.000000; -NODES[1934](IS_STRUCTURE,0) = 1.000000; -NODES[1935](IS_STRUCTURE,0) = 1.000000; -NODES[1936](IS_STRUCTURE,0) = 1.000000; -NODES[1937](IS_STRUCTURE,0) = 1.000000; -NODES[1940](IS_STRUCTURE,0) = 1.000000; -NODES[1943](IS_STRUCTURE,0) = 1.000000; -NODES[1944](IS_STRUCTURE,0) = 1.000000; -NODES[1945](IS_STRUCTURE,0) = 1.000000; -NODES[1946](IS_STRUCTURE,0) = 1.000000; -NODES[1947](IS_STRUCTURE,0) = 1.000000; -NODES[1950](IS_STRUCTURE,0) = 1.000000; -NODES[1951](IS_STRUCTURE,0) = 1.000000; -NODES[1953](IS_STRUCTURE,0) = 1.000000; -NODES[1954](IS_STRUCTURE,0) = 1.000000; -NODES[1957](IS_STRUCTURE,0) = 1.000000; -NODES[1962](IS_STRUCTURE,0) = 1.000000; -NODES[1963](IS_STRUCTURE,0) = 1.000000; -NODES[1965](IS_STRUCTURE,0) = 1.000000; -NODES[1968](IS_STRUCTURE,0) = 1.000000; -NODES[1970](IS_STRUCTURE,0) = 1.000000; -NODES[1971](IS_STRUCTURE,0) = 1.000000; -NODES[1974](IS_STRUCTURE,0) = 1.000000; -NODES[1979](IS_STRUCTURE,0) = 1.000000; -NODES[1980](IS_STRUCTURE,0) = 1.000000; -NODES[1981](IS_STRUCTURE,0) = 1.000000; -NODES[1982](IS_STRUCTURE,0) = 1.000000; -NODES[1983](IS_STRUCTURE,0) = 1.000000; -NODES[1984](IS_STRUCTURE,0) = 1.000000; -NODES[1986](IS_STRUCTURE,0) = 1.000000; -NODES[1988](IS_STRUCTURE,0) = 1.000000; -NODES[1990](IS_STRUCTURE,0) = 1.000000; -NODES[1991](IS_STRUCTURE,0) = 1.000000; -NODES[1993](IS_STRUCTURE,0) = 1.000000; -NODES[1994](IS_STRUCTURE,0) = 1.000000; -NODES[1996](IS_STRUCTURE,0) = 1.000000; -NODES[1998](IS_STRUCTURE,0) = 1.000000; -NODES[2000](IS_STRUCTURE,0) = 1.000000; -NODES[2003](IS_STRUCTURE,0) = 1.000000; -NODES[2004](IS_STRUCTURE,0) = 1.000000; -NODES[2005](IS_STRUCTURE,0) = 1.000000; -NODES[2011](IS_STRUCTURE,0) = 1.000000; -NODES[2014](IS_STRUCTURE,0) = 1.000000; -NODES[2015](IS_STRUCTURE,0) = 1.000000; -NODES[2016](IS_STRUCTURE,0) = 1.000000; -NODES[2017](IS_STRUCTURE,0) = 1.000000; -NODES[2020](IS_STRUCTURE,0) = 1.000000; -NODES[2023](IS_STRUCTURE,0) = 1.000000; -NODES[2024](IS_STRUCTURE,0) = 1.000000; -NODES[2029](IS_STRUCTURE,0) = 1.000000; -NODES[2031](IS_STRUCTURE,0) = 1.000000; -NODES[2035](IS_STRUCTURE,0) = 1.000000; -NODES[2036](IS_STRUCTURE,0) = 1.000000; -NODES[2039](IS_STRUCTURE,0) = 1.000000; -NODES[2040](IS_STRUCTURE,0) = 1.000000; -NODES[2042](IS_STRUCTURE,0) = 1.000000; -NODES[2044](IS_STRUCTURE,0) = 1.000000; -NODES[2048](IS_STRUCTURE,0) = 1.000000; -NODES[2049](IS_STRUCTURE,0) = 1.000000; -NODES[2050](IS_STRUCTURE,0) = 1.000000; -NODES[2053](IS_STRUCTURE,0) = 1.000000; -NODES[2055](IS_STRUCTURE,0) = 1.000000; -NODES[2059](IS_STRUCTURE,0) = 1.000000; -NODES[2063](IS_STRUCTURE,0) = 1.000000; -NODES[2067](IS_STRUCTURE,0) = 1.000000; -NODES[2068](IS_STRUCTURE,0) = 1.000000; -NODES[2069](IS_STRUCTURE,0) = 1.000000; -NODES[2070](IS_STRUCTURE,0) = 1.000000; -NODES[2073](IS_STRUCTURE,0) = 1.000000; -NODES[2077](IS_STRUCTURE,0) = 1.000000; -NODES[2082](IS_STRUCTURE,0) = 1.000000; -NODES[2084](IS_STRUCTURE,0) = 1.000000; -NODES[2085](IS_STRUCTURE,0) = 1.000000; -NODES[2088](IS_STRUCTURE,0) = 1.000000; -NODES[2089](IS_STRUCTURE,0) = 1.000000; -NODES[2090](IS_STRUCTURE,0) = 1.000000; -NODES[2091](IS_STRUCTURE,0) = 1.000000; -NODES[2093](IS_STRUCTURE,0) = 1.000000; -NODES[2095](IS_STRUCTURE,0) = 1.000000; -NODES[2097](IS_STRUCTURE,0) = 1.000000; -NODES[2100](IS_STRUCTURE,0) = 1.000000; -NODES[2101](IS_STRUCTURE,0) = 1.000000; -NODES[2102](IS_STRUCTURE,0) = 1.000000; -NODES[2103](IS_STRUCTURE,0) = 1.000000; -NODES[2104](IS_STRUCTURE,0) = 1.000000; -NODES[2105](IS_STRUCTURE,0) = 1.000000; -NODES[2107](IS_STRUCTURE,0) = 1.000000; -NODES[2110](IS_STRUCTURE,0) = 1.000000; -NODES[2111](IS_STRUCTURE,0) = 1.000000; -NODES[2112](IS_STRUCTURE,0) = 1.000000; -NODES[2113](IS_STRUCTURE,0) = 1.000000; -NODES[2115](IS_STRUCTURE,0) = 1.000000; -NODES[2117](IS_STRUCTURE,0) = 1.000000; -NODES[2119](IS_STRUCTURE,0) = 1.000000; -NODES[2120](IS_STRUCTURE,0) = 1.000000; -NODES[2121](IS_STRUCTURE,0) = 1.000000; -NODES[2125](IS_STRUCTURE,0) = 1.000000; -NODES[2127](IS_STRUCTURE,0) = 1.000000; -NODES[2128](IS_STRUCTURE,0) = 1.000000; -NODES[2129](IS_STRUCTURE,0) = 1.000000; -NODES[2131](IS_STRUCTURE,0) = 1.000000; -NODES[2133](IS_STRUCTURE,0) = 1.000000; -NODES[2136](IS_STRUCTURE,0) = 1.000000; -NODES[2138](IS_STRUCTURE,0) = 1.000000; -NODES[2139](IS_STRUCTURE,0) = 1.000000; -NODES[2140](IS_STRUCTURE,0) = 1.000000; -NODES[2145](IS_STRUCTURE,0) = 1.000000; -NODES[2148](IS_STRUCTURE,0) = 1.000000; -NODES[2149](IS_STRUCTURE,0) = 1.000000; -NODES[2150](IS_STRUCTURE,0) = 1.000000; -NODES[2153](IS_STRUCTURE,0) = 1.000000; -NODES[2155](IS_STRUCTURE,0) = 1.000000; -NODES[2158](IS_STRUCTURE,0) = 1.000000; -NODES[2159](IS_STRUCTURE,0) = 1.000000; -NODES[2161](IS_STRUCTURE,0) = 1.000000; -NODES[2164](IS_STRUCTURE,0) = 1.000000; -NODES[2165](IS_STRUCTURE,0) = 1.000000; -NODES[2168](IS_STRUCTURE,0) = 1.000000; -NODES[2169](IS_STRUCTURE,0) = 1.000000; -NODES[2172](IS_STRUCTURE,0) = 1.000000; -NODES[2176](IS_STRUCTURE,0) = 1.000000; -NODES[2177](IS_STRUCTURE,0) = 1.000000; -NODES[2180](IS_STRUCTURE,0) = 1.000000; -NODES[2181](IS_STRUCTURE,0) = 1.000000; -NODES[2183](IS_STRUCTURE,0) = 1.000000; -NODES[2184](IS_STRUCTURE,0) = 1.000000; -NODES[2189](IS_STRUCTURE,0) = 1.000000; -NODES[2190](IS_STRUCTURE,0) = 1.000000; -NODES[2191](IS_STRUCTURE,0) = 1.000000; -NODES[2192](IS_STRUCTURE,0) = 1.000000; -NODES[2195](IS_STRUCTURE,0) = 1.000000; -NODES[2202](IS_STRUCTURE,0) = 1.000000; -NODES[2205](IS_STRUCTURE,0) = 1.000000; -NODES[2208](IS_STRUCTURE,0) = 1.000000; -NODES[2209](IS_STRUCTURE,0) = 1.000000; -NODES[2216](IS_STRUCTURE,0) = 1.000000; -NODES[2217](IS_STRUCTURE,0) = 1.000000; -NODES[2218](IS_STRUCTURE,0) = 1.000000; -NODES[2225](IS_STRUCTURE,0) = 1.000000; -NODES[2227](IS_STRUCTURE,0) = 1.000000; -NODES[2230](IS_STRUCTURE,0) = 1.000000; -NODES[2231](IS_STRUCTURE,0) = 1.000000; -NODES[2236](IS_STRUCTURE,0) = 1.000000; -NODES[2238](IS_STRUCTURE,0) = 1.000000; -NODES[2242](IS_STRUCTURE,0) = 1.000000; -NODES[2244](IS_STRUCTURE,0) = 1.000000; -NODES[2246](IS_STRUCTURE,0) = 1.000000; -NODES[2247](IS_STRUCTURE,0) = 1.000000; -NODES[2251](IS_STRUCTURE,0) = 1.000000; -NODES[2255](IS_STRUCTURE,0) = 1.000000; -NODES[2265](IS_STRUCTURE,0) = 1.000000; -NODES[2268](IS_STRUCTURE,0) = 1.000000; -NODES[2274](IS_STRUCTURE,0) = 1.000000; -NODES[2277](IS_STRUCTURE,0) = 1.000000; -NODES[2278](IS_STRUCTURE,0) = 1.000000; -NODES[2284](IS_STRUCTURE,0) = 1.000000; -NODES[2285](IS_STRUCTURE,0) = 1.000000; -NODES[2286](IS_STRUCTURE,0) = 1.000000; -NODES[2293](IS_STRUCTURE,0) = 1.000000; -NODES[2295](IS_STRUCTURE,0) = 1.000000; -NODES[2297](IS_STRUCTURE,0) = 1.000000; -NODES[2299](IS_STRUCTURE,0) = 1.000000; -NODES[2302](IS_STRUCTURE,0) = 1.000000; -NODES[2303](IS_STRUCTURE,0) = 1.000000; -NODES[2304](IS_STRUCTURE,0) = 1.000000; -NODES[2305](IS_STRUCTURE,0) = 1.000000; -NODES[2306](IS_STRUCTURE,0) = 1.000000; -NODES[2307](IS_STRUCTURE,0) = 1.000000; -NODES[2308](IS_STRUCTURE,0) = 1.000000; -NODES[2309](IS_STRUCTURE,0) = 1.000000; -NODES[2315](IS_STRUCTURE,0) = 1.000000; -NODES[2316](IS_STRUCTURE,0) = 1.000000; -NODES[2321](IS_STRUCTURE,0) = 1.000000; -NODES[2323](IS_STRUCTURE,0) = 1.000000; -NODES[2324](IS_STRUCTURE,0) = 1.000000; -NODES[2325](IS_STRUCTURE,0) = 1.000000; -NODES[2328](IS_STRUCTURE,0) = 1.000000; -NODES[2329](IS_STRUCTURE,0) = 1.000000; -NODES[2330](IS_STRUCTURE,0) = 1.000000; -NODES[2331](IS_STRUCTURE,0) = 1.000000; -NODES[2332](IS_STRUCTURE,0) = 1.000000; -NODES[2333](IS_STRUCTURE,0) = 1.000000; -NODES[2335](IS_STRUCTURE,0) = 1.000000; -NODES[2336](IS_STRUCTURE,0) = 1.000000; -NODES[2345](IS_STRUCTURE,0) = 1.000000; -NODES[2347](IS_STRUCTURE,0) = 1.000000; -NODES[2348](IS_STRUCTURE,0) = 1.000000; -NODES[2351](IS_STRUCTURE,0) = 1.000000; -NODES[2356](IS_STRUCTURE,0) = 1.000000; -NODES[2358](IS_STRUCTURE,0) = 1.000000; -NODES[2359](IS_STRUCTURE,0) = 1.000000; -NODES[2360](IS_STRUCTURE,0) = 1.000000; -NODES[2361](IS_STRUCTURE,0) = 1.000000; -NODES[2362](IS_STRUCTURE,0) = 1.000000; -NODES[2363](IS_STRUCTURE,0) = 1.000000; -NODES[2369](IS_STRUCTURE,0) = 1.000000; -NODES[2370](IS_STRUCTURE,0) = 1.000000; -NODES[2371](IS_STRUCTURE,0) = 1.000000; -NODES[2375](IS_STRUCTURE,0) = 1.000000; -NODES[2376](IS_STRUCTURE,0) = 1.000000; -NODES[2377](IS_STRUCTURE,0) = 1.000000; -NODES[2382](IS_STRUCTURE,0) = 1.000000; -NODES[2388](IS_STRUCTURE,0) = 1.000000; -NODES[2392](IS_STRUCTURE,0) = 1.000000; -NODES[2393](IS_STRUCTURE,0) = 1.000000; -NODES[2395](IS_STRUCTURE,0) = 1.000000; -NODES[2397](IS_STRUCTURE,0) = 1.000000; -NODES[2399](IS_STRUCTURE,0) = 1.000000; -NODES[2405](IS_STRUCTURE,0) = 1.000000; -NODES[2411](IS_STRUCTURE,0) = 1.000000; -NODES[2412](IS_STRUCTURE,0) = 1.000000; -NODES[2418](IS_STRUCTURE,0) = 1.000000; -NODES[2424](IS_STRUCTURE,0) = 1.000000; -NODES[2428](IS_STRUCTURE,0) = 1.000000; -NODES[2429](IS_STRUCTURE,0) = 1.000000; -NODES[2430](IS_STRUCTURE,0) = 1.000000; -NODES[2434](IS_STRUCTURE,0) = 1.000000; -NODES[2435](IS_STRUCTURE,0) = 1.000000; -NODES[2443](IS_STRUCTURE,0) = 1.000000; -NODES[2446](IS_STRUCTURE,0) = 1.000000; -NODES[2452](IS_STRUCTURE,0) = 1.000000; -NODES[2457](IS_STRUCTURE,0) = 1.000000; -NODES[2458](IS_STRUCTURE,0) = 1.000000; -NODES[2459](IS_STRUCTURE,0) = 1.000000; -NODES[2461](IS_STRUCTURE,0) = 1.000000; -NODES[2462](IS_STRUCTURE,0) = 1.000000; -NODES[2470](IS_STRUCTURE,0) = 1.000000; -NODES[2472](IS_STRUCTURE,0) = 1.000000; -NODES[2473](IS_STRUCTURE,0) = 1.000000; -NODES[2478](IS_STRUCTURE,0) = 1.000000; -NODES[2479](IS_STRUCTURE,0) = 1.000000; -NODES[2488](IS_STRUCTURE,0) = 1.000000; -NODES[2489](IS_STRUCTURE,0) = 1.000000; -NODES[2492](IS_STRUCTURE,0) = 1.000000; -NODES[2499](IS_STRUCTURE,0) = 1.000000; -NODES[2505](IS_STRUCTURE,0) = 1.000000; -NODES[2506](IS_STRUCTURE,0) = 1.000000; -NODES[2508](IS_STRUCTURE,0) = 1.000000; -NODES[2510](IS_STRUCTURE,0) = 1.000000; -NODES[2513](IS_STRUCTURE,0) = 1.000000; -NODES[2515](IS_STRUCTURE,0) = 1.000000; -NODES[2519](IS_STRUCTURE,0) = 1.000000; -NODES[2521](IS_STRUCTURE,0) = 1.000000; -NODES[2525](IS_STRUCTURE,0) = 1.000000; -NODES[2526](IS_STRUCTURE,0) = 1.000000; -NODES[2530](IS_STRUCTURE,0) = 1.000000; -NODES[2533](IS_STRUCTURE,0) = 1.000000; -NODES[2540](IS_STRUCTURE,0) = 1.000000; -NODES[2543](IS_STRUCTURE,0) = 1.000000; -NODES[2545](IS_STRUCTURE,0) = 1.000000; -NODES[2549](IS_STRUCTURE,0) = 1.000000; -NODES[2551](IS_STRUCTURE,0) = 1.000000; -NODES[2552](IS_STRUCTURE,0) = 1.000000; -NODES[2554](IS_STRUCTURE,0) = 1.000000; -NODES[2559](IS_STRUCTURE,0) = 1.000000; -NODES[2560](IS_STRUCTURE,0) = 1.000000; -NODES[2571](IS_STRUCTURE,0) = 1.000000; -NODES[2573](IS_STRUCTURE,0) = 1.000000; -NODES[2574](IS_STRUCTURE,0) = 1.000000; -NODES[2575](IS_STRUCTURE,0) = 1.000000; -NODES[2576](IS_STRUCTURE,0) = 1.000000; -NODES[2579](IS_STRUCTURE,0) = 1.000000; -NODES[2580](IS_STRUCTURE,0) = 1.000000; -NODES[2584](IS_STRUCTURE,0) = 1.000000; -NODES[2585](IS_STRUCTURE,0) = 1.000000; -NODES[2587](IS_STRUCTURE,0) = 1.000000; -NODES[2589](IS_STRUCTURE,0) = 1.000000; -NODES[2591](IS_STRUCTURE,0) = 1.000000; -NODES[2596](IS_STRUCTURE,0) = 1.000000; -NODES[2597](IS_STRUCTURE,0) = 1.000000; -NODES[2599](IS_STRUCTURE,0) = 1.000000; -NODES[2600](IS_STRUCTURE,0) = 1.000000; -NODES[2603](IS_STRUCTURE,0) = 1.000000; -NODES[2604](IS_STRUCTURE,0) = 1.000000; -NODES[2608](IS_STRUCTURE,0) = 1.000000; -NODES[2612](IS_STRUCTURE,0) = 1.000000; -NODES[2617](IS_STRUCTURE,0) = 1.000000; -NODES[2621](IS_STRUCTURE,0) = 1.000000; -NODES[2622](IS_STRUCTURE,0) = 1.000000; -NODES[2624](IS_STRUCTURE,0) = 1.000000; -NODES[2625](IS_STRUCTURE,0) = 1.000000; -NODES[2629](IS_STRUCTURE,0) = 1.000000; -NODES[2631](IS_STRUCTURE,0) = 1.000000; -NODES[2632](IS_STRUCTURE,0) = 1.000000; -NODES[2633](IS_STRUCTURE,0) = 1.000000; -NODES[2643](IS_STRUCTURE,0) = 1.000000; -NODES[2645](IS_STRUCTURE,0) = 1.000000; -NODES[2646](IS_STRUCTURE,0) = 1.000000; -NODES[2656](IS_STRUCTURE,0) = 1.000000; -NODES[2657](IS_STRUCTURE,0) = 1.000000; -NODES[2658](IS_STRUCTURE,0) = 1.000000; -NODES[2661](IS_STRUCTURE,0) = 1.000000; -NODES[2663](IS_STRUCTURE,0) = 1.000000; -NODES[2668](IS_STRUCTURE,0) = 1.000000; -NODES[2669](IS_STRUCTURE,0) = 1.000000; -NODES[2678](IS_STRUCTURE,0) = 1.000000; -NODES[2679](IS_STRUCTURE,0) = 1.000000; -NODES[2684](IS_STRUCTURE,0) = 1.000000; -NODES[2685](IS_STRUCTURE,0) = 1.000000; -NODES[2690](IS_STRUCTURE,0) = 1.000000; -NODES[2691](IS_STRUCTURE,0) = 1.000000; -NODES[2693](IS_STRUCTURE,0) = 1.000000; -NODES[2698](IS_STRUCTURE,0) = 1.000000; -NODES[2702](IS_STRUCTURE,0) = 1.000000; -NODES[2707](IS_STRUCTURE,0) = 1.000000; -NODES[2712](IS_STRUCTURE,0) = 1.000000; -NODES[2726](IS_STRUCTURE,0) = 1.000000; -NODES[2730](IS_STRUCTURE,0) = 1.000000; -NODES[2731](IS_STRUCTURE,0) = 1.000000; -NODES[2732](IS_STRUCTURE,0) = 1.000000; -NODES[2737](IS_STRUCTURE,0) = 1.000000; -NODES[2754](IS_STRUCTURE,0) = 1.000000; -NODES[2755](IS_STRUCTURE,0) = 1.000000; -NODES[2757](IS_STRUCTURE,0) = 1.000000; -NODES[2758](IS_STRUCTURE,0) = 1.000000; -NODES[2759](IS_STRUCTURE,0) = 1.000000; -NODES[2764](IS_STRUCTURE,0) = 1.000000; -NODES[2766](IS_STRUCTURE,0) = 1.000000; -NODES[2769](IS_STRUCTURE,0) = 1.000000; -NODES[2773](IS_STRUCTURE,0) = 1.000000; -NODES[2780](IS_STRUCTURE,0) = 1.000000; -NODES[2782](IS_STRUCTURE,0) = 1.000000; -NODES[2785](IS_STRUCTURE,0) = 1.000000; -NODES[2786](IS_STRUCTURE,0) = 1.000000; -NODES[2787](IS_STRUCTURE,0) = 1.000000; -NODES[2790](IS_STRUCTURE,0) = 1.000000; -NODES[2791](IS_STRUCTURE,0) = 1.000000; -NODES[2795](IS_STRUCTURE,0) = 1.000000; -NODES[2796](IS_STRUCTURE,0) = 1.000000; -NODES[2802](IS_STRUCTURE,0) = 1.000000; -NODES[2807](IS_STRUCTURE,0) = 1.000000; -NODES[2809](IS_STRUCTURE,0) = 1.000000; -NODES[2810](IS_STRUCTURE,0) = 1.000000; -NODES[2814](IS_STRUCTURE,0) = 1.000000; -NODES[2815](IS_STRUCTURE,0) = 1.000000; -NODES[2821](IS_STRUCTURE,0) = 1.000000; -NODES[2822](IS_STRUCTURE,0) = 1.000000; -NODES[2824](IS_STRUCTURE,0) = 1.000000; -NODES[2829](IS_STRUCTURE,0) = 1.000000; -NODES[2837](IS_STRUCTURE,0) = 1.000000; -NODES[2839](IS_STRUCTURE,0) = 1.000000; -NODES[2848](IS_STRUCTURE,0) = 1.000000; -NODES[2850](IS_STRUCTURE,0) = 1.000000; -NODES[2856](IS_STRUCTURE,0) = 1.000000; -NODES[2857](IS_STRUCTURE,0) = 1.000000; -NODES[2861](IS_STRUCTURE,0) = 1.000000; -NODES[2862](IS_STRUCTURE,0) = 1.000000; -NODES[2867](IS_STRUCTURE,0) = 1.000000; -NODES[2873](IS_STRUCTURE,0) = 1.000000; -NODES[2874](IS_STRUCTURE,0) = 1.000000; -NODES[2877](IS_STRUCTURE,0) = 1.000000; -NODES[2879](IS_STRUCTURE,0) = 1.000000; -NODES[2887](IS_STRUCTURE,0) = 1.000000; -NODES[2893](IS_STRUCTURE,0) = 1.000000; -NODES[2894](IS_STRUCTURE,0) = 1.000000; -NODES[2896](IS_STRUCTURE,0) = 1.000000; -NODES[2897](IS_STRUCTURE,0) = 1.000000; -NODES[2901](IS_STRUCTURE,0) = 1.000000; -NODES[2903](IS_STRUCTURE,0) = 1.000000; -NODES[2907](IS_STRUCTURE,0) = 1.000000; -NODES[2908](IS_STRUCTURE,0) = 1.000000; -NODES[2909](IS_STRUCTURE,0) = 1.000000; -NODES[2915](IS_STRUCTURE,0) = 1.000000; -NODES[2918](IS_STRUCTURE,0) = 1.000000; -NODES[2921](IS_STRUCTURE,0) = 1.000000; -NODES[2922](IS_STRUCTURE,0) = 1.000000; -NODES[2923](IS_STRUCTURE,0) = 1.000000; -NODES[2929](IS_STRUCTURE,0) = 1.000000; -NODES[2933](IS_STRUCTURE,0) = 1.000000; -NODES[2934](IS_STRUCTURE,0) = 1.000000; -NODES[2937](IS_STRUCTURE,0) = 1.000000; -NODES[2939](IS_STRUCTURE,0) = 1.000000; -NODES[2942](IS_STRUCTURE,0) = 1.000000; -NODES[2950](IS_STRUCTURE,0) = 1.000000; -NODES[2951](IS_STRUCTURE,0) = 1.000000; -NODES[2958](IS_STRUCTURE,0) = 1.000000; -NODES[2966](IS_STRUCTURE,0) = 1.000000; -NODES[2967](IS_STRUCTURE,0) = 1.000000; -NODES[2968](IS_STRUCTURE,0) = 1.000000; -NODES[2972](IS_STRUCTURE,0) = 1.000000; -NODES[2975](IS_STRUCTURE,0) = 1.000000; -NODES[2977](IS_STRUCTURE,0) = 1.000000; -NODES[2982](IS_STRUCTURE,0) = 1.000000; -NODES[2983](IS_STRUCTURE,0) = 1.000000; -NODES[2990](IS_STRUCTURE,0) = 1.000000; -NODES[2991](IS_STRUCTURE,0) = 1.000000; -NODES[2992](IS_STRUCTURE,0) = 1.000000; -NODES[3001](IS_STRUCTURE,0) = 1.000000; -NODES[3003](IS_STRUCTURE,0) = 1.000000; -NODES[3004](IS_STRUCTURE,0) = 1.000000; -NODES[3005](IS_STRUCTURE,0) = 1.000000; -NODES[3006](IS_STRUCTURE,0) = 1.000000; -NODES[3021](IS_STRUCTURE,0) = 1.000000; -NODES[3028](IS_STRUCTURE,0) = 1.000000; -NODES[3029](IS_STRUCTURE,0) = 1.000000; -NODES[3030](IS_STRUCTURE,0) = 1.000000; -NODES[3033](IS_STRUCTURE,0) = 1.000000; -NODES[3034](IS_STRUCTURE,0) = 1.000000; -NODES[3039](IS_STRUCTURE,0) = 1.000000; -NODES[3045](IS_STRUCTURE,0) = 1.000000; -NODES[3048](IS_STRUCTURE,0) = 1.000000; -NODES[3051](IS_STRUCTURE,0) = 1.000000; -NODES[3054](IS_STRUCTURE,0) = 1.000000; -NODES[3055](IS_STRUCTURE,0) = 1.000000; -NODES[3058](IS_STRUCTURE,0) = 1.000000; -NODES[3059](IS_STRUCTURE,0) = 1.000000; -NODES[3063](IS_STRUCTURE,0) = 1.000000; -NODES[3079](IS_STRUCTURE,0) = 1.000000; -NODES[3083](IS_STRUCTURE,0) = 1.000000; -NODES[3085](IS_STRUCTURE,0) = 1.000000; -NODES[3086](IS_STRUCTURE,0) = 1.000000; -NODES[3091](IS_STRUCTURE,0) = 1.000000; -NODES[3093](IS_STRUCTURE,0) = 1.000000; -NODES[3097](IS_STRUCTURE,0) = 1.000000; -NODES[3099](IS_STRUCTURE,0) = 1.000000; -NODES[3100](IS_STRUCTURE,0) = 1.000000; -NODES[3101](IS_STRUCTURE,0) = 1.000000; -NODES[3105](IS_STRUCTURE,0) = 1.000000; -NODES[3110](IS_STRUCTURE,0) = 1.000000; -NODES[3119](IS_STRUCTURE,0) = 1.000000; -NODES[3121](IS_STRUCTURE,0) = 1.000000; -NODES[3131](IS_STRUCTURE,0) = 1.000000; -NODES[3134](IS_STRUCTURE,0) = 1.000000; -NODES[3153](IS_STRUCTURE,0) = 1.000000; -NODES[3161](IS_STRUCTURE,0) = 1.000000; -NODES[3165](IS_STRUCTURE,0) = 1.000000; -NODES[3166](IS_STRUCTURE,0) = 1.000000; -NODES[3167](IS_STRUCTURE,0) = 1.000000; -NODES[3170](IS_STRUCTURE,0) = 1.000000; -NODES[3171](IS_STRUCTURE,0) = 1.000000; -NODES[3177](IS_STRUCTURE,0) = 1.000000; -NODES[3194](IS_STRUCTURE,0) = 1.000000; -NODES[3199](IS_STRUCTURE,0) = 1.000000; -NODES[3217](IS_STRUCTURE,0) = 1.000000; -NODES[3218](IS_STRUCTURE,0) = 1.000000; -NODES[3220](IS_STRUCTURE,0) = 1.000000; -NODES[3225](IS_STRUCTURE,0) = 1.000000; -NODES[3228](IS_STRUCTURE,0) = 1.000000; -NODES[3240](IS_STRUCTURE,0) = 1.000000; -NODES[3241](IS_STRUCTURE,0) = 1.000000; -NODES[3243](IS_STRUCTURE,0) = 1.000000; -NODES[3251](IS_STRUCTURE,0) = 1.000000; -NODES[3258](IS_STRUCTURE,0) = 1.000000; -NODES[3264](IS_STRUCTURE,0) = 1.000000; -NODES[3265](IS_STRUCTURE,0) = 1.000000; -NODES[3268](IS_STRUCTURE,0) = 1.000000; -NODES[3270](IS_STRUCTURE,0) = 1.000000; -NODES[3272](IS_STRUCTURE,0) = 1.000000; -NODES[3275](IS_STRUCTURE,0) = 1.000000; -NODES[3276](IS_STRUCTURE,0) = 1.000000; -NODES[3278](IS_STRUCTURE,0) = 1.000000; -NODES[3279](IS_STRUCTURE,0) = 1.000000; -NODES[3280](IS_STRUCTURE,0) = 1.000000; -NODES[3282](IS_STRUCTURE,0) = 1.000000; -NODES[3283](IS_STRUCTURE,0) = 1.000000; -NODES[3287](IS_STRUCTURE,0) = 1.000000; -NODES[3293](IS_STRUCTURE,0) = 1.000000; -NODES[3294](IS_STRUCTURE,0) = 1.000000; -NODES[3297](IS_STRUCTURE,0) = 1.000000; -NODES[3301](IS_STRUCTURE,0) = 1.000000; -NODES[3302](IS_STRUCTURE,0) = 1.000000; -NODES[3303](IS_STRUCTURE,0) = 1.000000; -NODES[3309](IS_STRUCTURE,0) = 1.000000; -NODES[3311](IS_STRUCTURE,0) = 1.000000; -NODES[3315](IS_STRUCTURE,0) = 1.000000; -NODES[3322](IS_STRUCTURE,0) = 1.000000; -NODES[3323](IS_STRUCTURE,0) = 1.000000; -NODES[3324](IS_STRUCTURE,0) = 1.000000; -NODES[3325](IS_STRUCTURE,0) = 1.000000; -NODES[3341](IS_STRUCTURE,0) = 1.000000; -NODES[3345](IS_STRUCTURE,0) = 1.000000; -NODES[3346](IS_STRUCTURE,0) = 1.000000; -NODES[3348](IS_STRUCTURE,0) = 1.000000; -NODES[3350](IS_STRUCTURE,0) = 1.000000; -NODES[3352](IS_STRUCTURE,0) = 1.000000; -NODES[3354](IS_STRUCTURE,0) = 1.000000; -NODES[3359](IS_STRUCTURE,0) = 1.000000; -NODES[3366](IS_STRUCTURE,0) = 1.000000; -NODES[3368](IS_STRUCTURE,0) = 1.000000; -NODES[3372](IS_STRUCTURE,0) = 1.000000; -NODES[3377](IS_STRUCTURE,0) = 1.000000; -NODES[3380](IS_STRUCTURE,0) = 1.000000; -NODES[3389](IS_STRUCTURE,0) = 1.000000; -NODES[3390](IS_STRUCTURE,0) = 1.000000; -NODES[3395](IS_STRUCTURE,0) = 1.000000; -NODES[3399](IS_STRUCTURE,0) = 1.000000; -NODES[3400](IS_STRUCTURE,0) = 1.000000; -NODES[3405](IS_STRUCTURE,0) = 1.000000; -NODES[3408](IS_STRUCTURE,0) = 1.000000; -NODES[3412](IS_STRUCTURE,0) = 1.000000; -NODES[3422](IS_STRUCTURE,0) = 1.000000; -NODES[3436](IS_STRUCTURE,0) = 1.000000; -NODES[3439](IS_STRUCTURE,0) = 1.000000; -NODES[3449](IS_STRUCTURE,0) = 1.000000; -NODES[3454](IS_STRUCTURE,0) = 1.000000; -NODES[3455](IS_STRUCTURE,0) = 1.000000; -NODES[3456](IS_STRUCTURE,0) = 1.000000; -NODES[3461](IS_STRUCTURE,0) = 1.000000; -NODES[3463](IS_STRUCTURE,0) = 1.000000; -NODES[3465](IS_STRUCTURE,0) = 1.000000; -NODES[3474](IS_STRUCTURE,0) = 1.000000; -NODES[3475](IS_STRUCTURE,0) = 1.000000; -NODES[3477](IS_STRUCTURE,0) = 1.000000; -NODES[3481](IS_STRUCTURE,0) = 1.000000; -NODES[3487](IS_STRUCTURE,0) = 1.000000; -NODES[3493](IS_STRUCTURE,0) = 1.000000; -NODES[3495](IS_STRUCTURE,0) = 1.000000; -NODES[3496](IS_STRUCTURE,0) = 1.000000; -NODES[3500](IS_STRUCTURE,0) = 1.000000; -NODES[3521](IS_STRUCTURE,0) = 1.000000; -NODES[3524](IS_STRUCTURE,0) = 1.000000; -NODES[3529](IS_STRUCTURE,0) = 1.000000; -NODES[3531](IS_STRUCTURE,0) = 1.000000; -NODES[3532](IS_STRUCTURE,0) = 1.000000; -NODES[3539](IS_STRUCTURE,0) = 1.000000; -NODES[3541](IS_STRUCTURE,0) = 1.000000; -NODES[3543](IS_STRUCTURE,0) = 1.000000; -NODES[3558](IS_STRUCTURE,0) = 1.000000; -NODES[3567](IS_STRUCTURE,0) = 1.000000; -NODES[3571](IS_STRUCTURE,0) = 1.000000; -NODES[3580](IS_STRUCTURE,0) = 1.000000; -NODES[3585](IS_STRUCTURE,0) = 1.000000; -NODES[3587](IS_STRUCTURE,0) = 1.000000; -NODES[3615](IS_STRUCTURE,0) = 1.000000; -NODES[3620](IS_STRUCTURE,0) = 1.000000; -NODES[3621](IS_STRUCTURE,0) = 1.000000; -NODES[3624](IS_STRUCTURE,0) = 1.000000; -NODES[3626](IS_STRUCTURE,0) = 1.000000; -NODES[3627](IS_STRUCTURE,0) = 1.000000; -NODES[3628](IS_STRUCTURE,0) = 1.000000; -NODES[3633](IS_STRUCTURE,0) = 1.000000; -NODES[3645](IS_STRUCTURE,0) = 1.000000; -NODES[3648](IS_STRUCTURE,0) = 1.000000; -NODES[3650](IS_STRUCTURE,0) = 1.000000; -NODES[3653](IS_STRUCTURE,0) = 1.000000; -NODES[3657](IS_STRUCTURE,0) = 1.000000; -NODES[3664](IS_STRUCTURE,0) = 1.000000; -NODES[3674](IS_STRUCTURE,0) = 1.000000; -NODES[3685](IS_STRUCTURE,0) = 1.000000; -NODES[3689](IS_STRUCTURE,0) = 1.000000; -NODES[3690](IS_STRUCTURE,0) = 1.000000; -NODES[3693](IS_STRUCTURE,0) = 1.000000; -NODES[3694](IS_STRUCTURE,0) = 1.000000; -NODES[3695](IS_STRUCTURE,0) = 1.000000; -NODES[3697](IS_STRUCTURE,0) = 1.000000; -NODES[3701](IS_STRUCTURE,0) = 1.000000; -NODES[3702](IS_STRUCTURE,0) = 1.000000; -NODES[3703](IS_STRUCTURE,0) = 1.000000; -NODES[3705](IS_STRUCTURE,0) = 1.000000; -NODES[3706](IS_STRUCTURE,0) = 1.000000; -NODES[3707](IS_STRUCTURE,0) = 1.000000; -NODES[3709](IS_STRUCTURE,0) = 1.000000; -NODES[3710](IS_STRUCTURE,0) = 1.000000; -NODES[3711](IS_STRUCTURE,0) = 1.000000; -NODES[3715](IS_STRUCTURE,0) = 1.000000; -NODES[3718](IS_STRUCTURE,0) = 1.000000; -NODES[3722](IS_STRUCTURE,0) = 1.000000; -NODES[3724](IS_STRUCTURE,0) = 1.000000; -NODES[3729](IS_STRUCTURE,0) = 1.000000; -NODES[3732](IS_STRUCTURE,0) = 1.000000; -NODES[3733](IS_STRUCTURE,0) = 1.000000; -NODES[3735](IS_STRUCTURE,0) = 1.000000; -NODES[3736](IS_STRUCTURE,0) = 1.000000; -NODES[3742](IS_STRUCTURE,0) = 1.000000; -NODES[3749](IS_STRUCTURE,0) = 1.000000; -NODES[3750](IS_STRUCTURE,0) = 1.000000; -NODES[3753](IS_STRUCTURE,0) = 1.000000; -NODES[3757](IS_STRUCTURE,0) = 1.000000; -NODES[3758](IS_STRUCTURE,0) = 1.000000; -NODES[3759](IS_STRUCTURE,0) = 1.000000; -NODES[3761](IS_STRUCTURE,0) = 1.000000; -NODES[3775](IS_STRUCTURE,0) = 1.000000; -NODES[3790](IS_STRUCTURE,0) = 1.000000; -NODES[3791](IS_STRUCTURE,0) = 1.000000; -NODES[3792](IS_STRUCTURE,0) = 1.000000; -NODES[3803](IS_STRUCTURE,0) = 1.000000; -NODES[3804](IS_STRUCTURE,0) = 1.000000; -NODES[3806](IS_STRUCTURE,0) = 1.000000; -NODES[3821](IS_STRUCTURE,0) = 1.000000; -NODES[3824](IS_STRUCTURE,0) = 1.000000; -NODES[3830](IS_STRUCTURE,0) = 1.000000; -NODES[3833](IS_STRUCTURE,0) = 1.000000; -NODES[3836](IS_STRUCTURE,0) = 1.000000; -NODES[3841](IS_STRUCTURE,0) = 1.000000; -NODES[3849](IS_STRUCTURE,0) = 1.000000; -NODES[3850](IS_STRUCTURE,0) = 1.000000; -NODES[3858](IS_STRUCTURE,0) = 1.000000; -NODES[3859](IS_STRUCTURE,0) = 1.000000; -NODES[3865](IS_STRUCTURE,0) = 1.000000; -NODES[3870](IS_STRUCTURE,0) = 1.000000; -NODES[3872](IS_STRUCTURE,0) = 1.000000; -NODES[3887](IS_STRUCTURE,0) = 1.000000; -NODES[3889](IS_STRUCTURE,0) = 1.000000; -NODES[3891](IS_STRUCTURE,0) = 1.000000; -NODES[3896](IS_STRUCTURE,0) = 1.000000; -NODES[3901](IS_STRUCTURE,0) = 1.000000; -NODES[3915](IS_STRUCTURE,0) = 1.000000; -NODES[3920](IS_STRUCTURE,0) = 1.000000; -NODES[3921](IS_STRUCTURE,0) = 1.000000; -NODES[3923](IS_STRUCTURE,0) = 1.000000; -NODES[3929](IS_STRUCTURE,0) = 1.000000; -NODES[3931](IS_STRUCTURE,0) = 1.000000; -NODES[3937](IS_STRUCTURE,0) = 1.000000; -NODES[3938](IS_STRUCTURE,0) = 1.000000; -NODES[3953](IS_STRUCTURE,0) = 1.000000; -NODES[3963](IS_STRUCTURE,0) = 1.000000; -NODES[3968](IS_STRUCTURE,0) = 1.000000; -NODES[3969](IS_STRUCTURE,0) = 1.000000; -NODES[3972](IS_STRUCTURE,0) = 1.000000; -NODES[3975](IS_STRUCTURE,0) = 1.000000; -NODES[3981](IS_STRUCTURE,0) = 1.000000; -NODES[3987](IS_STRUCTURE,0) = 1.000000; -NODES[3997](IS_STRUCTURE,0) = 1.000000; -NODES[3998](IS_STRUCTURE,0) = 1.000000; -NODES[4002](IS_STRUCTURE,0) = 1.000000; -NODES[4006](IS_STRUCTURE,0) = 1.000000; -NODES[4018](IS_STRUCTURE,0) = 1.000000; -NODES[4020](IS_STRUCTURE,0) = 1.000000; -NODES[4021](IS_STRUCTURE,0) = 1.000000; -NODES[4024](IS_STRUCTURE,0) = 1.000000; -NODES[4038](IS_STRUCTURE,0) = 1.000000; -NODES[4042](IS_STRUCTURE,0) = 1.000000; -NODES[4046](IS_STRUCTURE,0) = 1.000000; -NODES[4050](IS_STRUCTURE,0) = 1.000000; -NODES[4065](IS_STRUCTURE,0) = 1.000000; -NODES[4073](IS_STRUCTURE,0) = 1.000000; -NODES[4076](IS_STRUCTURE,0) = 1.000000; -NODES[4079](IS_STRUCTURE,0) = 1.000000; -NODES[4082](IS_STRUCTURE,0) = 1.000000; -NODES[4085](IS_STRUCTURE,0) = 1.000000; -NODES[4093](IS_STRUCTURE,0) = 1.000000; -NODES[4095](IS_STRUCTURE,0) = 1.000000; -NODES[4096](IS_STRUCTURE,0) = 1.000000; -NODES[4099](IS_STRUCTURE,0) = 1.000000; -NODES[4108](IS_STRUCTURE,0) = 1.000000; -NODES[4114](IS_STRUCTURE,0) = 1.000000; -NODES[4115](IS_STRUCTURE,0) = 1.000000; -NODES[4123](IS_STRUCTURE,0) = 1.000000; -NODES[4124](IS_STRUCTURE,0) = 1.000000; -NODES[4138](IS_STRUCTURE,0) = 1.000000; -NODES[4148](IS_STRUCTURE,0) = 1.000000; -NODES[4149](IS_STRUCTURE,0) = 1.000000; -NODES[4151](IS_STRUCTURE,0) = 1.000000; -NODES[4152](IS_STRUCTURE,0) = 1.000000; -NODES[4157](IS_STRUCTURE,0) = 1.000000; -NODES[4158](IS_STRUCTURE,0) = 1.000000; -NODES[4161](IS_STRUCTURE,0) = 1.000000; -NODES[4163](IS_STRUCTURE,0) = 1.000000; -NODES[4167](IS_STRUCTURE,0) = 1.000000; -NODES[4168](IS_STRUCTURE,0) = 1.000000; -NODES[4172](IS_STRUCTURE,0) = 1.000000; -NODES[4174](IS_STRUCTURE,0) = 1.000000; -NODES[4178](IS_STRUCTURE,0) = 1.000000; -NODES[4179](IS_STRUCTURE,0) = 1.000000; -NODES[4187](IS_STRUCTURE,0) = 1.000000; -NODES[4188](IS_STRUCTURE,0) = 1.000000; -NODES[4191](IS_STRUCTURE,0) = 1.000000; -NODES[4192](IS_STRUCTURE,0) = 1.000000; -NODES[4197](IS_STRUCTURE,0) = 1.000000; -NODES[4200](IS_STRUCTURE,0) = 1.000000; -NODES[4201](IS_STRUCTURE,0) = 1.000000; -NODES[4211](IS_STRUCTURE,0) = 1.000000; -NODES[4227](IS_STRUCTURE,0) = 1.000000; -NODES[4235](IS_STRUCTURE,0) = 1.000000; -NODES[4236](IS_STRUCTURE,0) = 1.000000; -NODES[4245](IS_STRUCTURE,0) = 1.000000; -NODES[4246](IS_STRUCTURE,0) = 1.000000; -NODES[4247](IS_STRUCTURE,0) = 1.000000; -NODES[4252](IS_STRUCTURE,0) = 1.000000; -NODES[4256](IS_STRUCTURE,0) = 1.000000; -NODES[4257](IS_STRUCTURE,0) = 1.000000; -NODES[4270](IS_STRUCTURE,0) = 1.000000; -NODES[4277](IS_STRUCTURE,0) = 1.000000; -NODES[4283](IS_STRUCTURE,0) = 1.000000; -NODES[4298](IS_STRUCTURE,0) = 1.000000; -NODES[4299](IS_STRUCTURE,0) = 1.000000; -NODES[4309](IS_STRUCTURE,0) = 1.000000; -NODES[4310](IS_STRUCTURE,0) = 1.000000; -NODES[4313](IS_STRUCTURE,0) = 1.000000; -NODES[4316](IS_STRUCTURE,0) = 1.000000; -NODES[4329](IS_STRUCTURE,0) = 1.000000; -NODES[4332](IS_STRUCTURE,0) = 1.000000; -NODES[4333](IS_STRUCTURE,0) = 1.000000; -NODES[4336](IS_STRUCTURE,0) = 1.000000; -NODES[4342](IS_STRUCTURE,0) = 1.000000; -NODES[4346](IS_STRUCTURE,0) = 1.000000; -NODES[4347](IS_STRUCTURE,0) = 1.000000; -NODES[4358](IS_STRUCTURE,0) = 1.000000; -NODES[4366](IS_STRUCTURE,0) = 1.000000; -NODES[4373](IS_STRUCTURE,0) = 1.000000; -NODES[4374](IS_STRUCTURE,0) = 1.000000; -NODES[4382](IS_STRUCTURE,0) = 1.000000; -NODES[4394](IS_STRUCTURE,0) = 1.000000; -NODES[4396](IS_STRUCTURE,0) = 1.000000; -NODES[4397](IS_STRUCTURE,0) = 1.000000; -NODES[4398](IS_STRUCTURE,0) = 1.000000; -NODES[4400](IS_STRUCTURE,0) = 1.000000; -NODES[4401](IS_STRUCTURE,0) = 1.000000; -NODES[4402](IS_STRUCTURE,0) = 1.000000; -NODES[4412](IS_STRUCTURE,0) = 1.000000; -NODES[4435](IS_STRUCTURE,0) = 1.000000; -NODES[4438](IS_STRUCTURE,0) = 1.000000; -NODES[4455](IS_STRUCTURE,0) = 1.000000; -NODES[4456](IS_STRUCTURE,0) = 1.000000; -NODES[4457](IS_STRUCTURE,0) = 1.000000; -NODES[4458](IS_STRUCTURE,0) = 1.000000; -NODES[4470](IS_STRUCTURE,0) = 1.000000; -NODES[4484](IS_STRUCTURE,0) = 1.000000; -NODES[4498](IS_STRUCTURE,0) = 1.000000; -NODES[4505](IS_STRUCTURE,0) = 1.000000; -NODES[4513](IS_STRUCTURE,0) = 1.000000; -NODES[4515](IS_STRUCTURE,0) = 1.000000; -NODES[4530](IS_STRUCTURE,0) = 1.000000; -NODES[4535](IS_STRUCTURE,0) = 1.000000; -NODES[4547](IS_STRUCTURE,0) = 1.000000; -NODES[4549](IS_STRUCTURE,0) = 1.000000; -NODES[4551](IS_STRUCTURE,0) = 1.000000; -NODES[4553](IS_STRUCTURE,0) = 1.000000; -NODES[4554](IS_STRUCTURE,0) = 1.000000; -NODES[4563](IS_STRUCTURE,0) = 1.000000; -NODES[4575](IS_STRUCTURE,0) = 1.000000; -NODES[4576](IS_STRUCTURE,0) = 1.000000; -NODES[4581](IS_STRUCTURE,0) = 1.000000; -NODES[4582](IS_STRUCTURE,0) = 1.000000; -NODES[4586](IS_STRUCTURE,0) = 1.000000; -NODES[4588](IS_STRUCTURE,0) = 1.000000; -NODES[4594](IS_STRUCTURE,0) = 1.000000; -NODES[4598](IS_STRUCTURE,0) = 1.000000; -NODES[4599](IS_STRUCTURE,0) = 1.000000; -NODES[4605](IS_STRUCTURE,0) = 1.000000; -NODES[4607](IS_STRUCTURE,0) = 1.000000; -NODES[4611](IS_STRUCTURE,0) = 1.000000; -NODES[4616](IS_STRUCTURE,0) = 1.000000; -NODES[4627](IS_STRUCTURE,0) = 1.000000; -NODES[4632](IS_STRUCTURE,0) = 1.000000; -NODES[4642](IS_STRUCTURE,0) = 1.000000; -NODES[4647](IS_STRUCTURE,0) = 1.000000; -NODES[4648](IS_STRUCTURE,0) = 1.000000; -NODES[4652](IS_STRUCTURE,0) = 1.000000; -NODES[4665](IS_STRUCTURE,0) = 1.000000; -NODES[4670](IS_STRUCTURE,0) = 1.000000; -NODES[4671](IS_STRUCTURE,0) = 1.000000; -NODES[4674](IS_STRUCTURE,0) = 1.000000; -NODES[4675](IS_STRUCTURE,0) = 1.000000; -NODES[4678](IS_STRUCTURE,0) = 1.000000; -NODES[4686](IS_STRUCTURE,0) = 1.000000; -NODES[4687](IS_STRUCTURE,0) = 1.000000; -NODES[4696](IS_STRUCTURE,0) = 1.000000; -NODES[4697](IS_STRUCTURE,0) = 1.000000; -NODES[4702](IS_STRUCTURE,0) = 1.000000; -NODES[4703](IS_STRUCTURE,0) = 1.000000; -NODES[4704](IS_STRUCTURE,0) = 1.000000; -NODES[4706](IS_STRUCTURE,0) = 1.000000; -NODES[4707](IS_STRUCTURE,0) = 1.000000; -NODES[4716](IS_STRUCTURE,0) = 1.000000; -NODES[4728](IS_STRUCTURE,0) = 1.000000; -NODES[4729](IS_STRUCTURE,0) = 1.000000; -NODES[4732](IS_STRUCTURE,0) = 1.000000; -NODES[4735](IS_STRUCTURE,0) = 1.000000; -NODES[4736](IS_STRUCTURE,0) = 1.000000; -NODES[4748](IS_STRUCTURE,0) = 1.000000; -NODES[4749](IS_STRUCTURE,0) = 1.000000; -NODES[4760](IS_STRUCTURE,0) = 1.000000; -NODES[4764](IS_STRUCTURE,0) = 1.000000; -NODES[4770](IS_STRUCTURE,0) = 1.000000; -NODES[4773](IS_STRUCTURE,0) = 1.000000; -NODES[4781](IS_STRUCTURE,0) = 1.000000; -NODES[4785](IS_STRUCTURE,0) = 1.000000; -NODES[4786](IS_STRUCTURE,0) = 1.000000; -NODES[4789](IS_STRUCTURE,0) = 1.000000; -NODES[4790](IS_STRUCTURE,0) = 1.000000; -NODES[4823](IS_STRUCTURE,0) = 1.000000; -NODES[4824](IS_STRUCTURE,0) = 1.000000; -NODES[4836](IS_STRUCTURE,0) = 1.000000; -NODES[4847](IS_STRUCTURE,0) = 1.000000; -NODES[4848](IS_STRUCTURE,0) = 1.000000; -NODES[4856](IS_STRUCTURE,0) = 1.000000; -NODES[4865](IS_STRUCTURE,0) = 1.000000; -NODES[4866](IS_STRUCTURE,0) = 1.000000; -NODES[4868](IS_STRUCTURE,0) = 1.000000; -NODES[4869](IS_STRUCTURE,0) = 1.000000; -NODES[4877](IS_STRUCTURE,0) = 1.000000; -NODES[4886](IS_STRUCTURE,0) = 1.000000; -NODES[4895](IS_STRUCTURE,0) = 1.000000; -NODES[4904](IS_STRUCTURE,0) = 1.000000; -NODES[4908](IS_STRUCTURE,0) = 1.000000; -NODES[4917](IS_STRUCTURE,0) = 1.000000; -NODES[4925](IS_STRUCTURE,0) = 1.000000; -NODES[4931](IS_STRUCTURE,0) = 1.000000; -NODES[4932](IS_STRUCTURE,0) = 1.000000; -NODES[4945](IS_STRUCTURE,0) = 1.000000; -NODES[4960](IS_STRUCTURE,0) = 1.000000; -NODES[4961](IS_STRUCTURE,0) = 1.000000; -NODES[4966](IS_STRUCTURE,0) = 1.000000; -NODES[4967](IS_STRUCTURE,0) = 1.000000; -NODES[4970](IS_STRUCTURE,0) = 1.000000; -NODES[4981](IS_STRUCTURE,0) = 1.000000; -NODES[4982](IS_STRUCTURE,0) = 1.000000; -NODES[4984](IS_STRUCTURE,0) = 1.000000; -NODES[4988](IS_STRUCTURE,0) = 1.000000; -NODES[4995](IS_STRUCTURE,0) = 1.000000; -NODES[5000](IS_STRUCTURE,0) = 1.000000; -NODES[5001](IS_STRUCTURE,0) = 1.000000; -NODES[5011](IS_STRUCTURE,0) = 1.000000; -NODES[5012](IS_STRUCTURE,0) = 1.000000; -NODES[5024](IS_STRUCTURE,0) = 1.000000; -NODES[5027](IS_STRUCTURE,0) = 1.000000; -NODES[5029](IS_STRUCTURE,0) = 1.000000; -NODES[5034](IS_STRUCTURE,0) = 1.000000; -NODES[5041](IS_STRUCTURE,0) = 1.000000; -NODES[5042](IS_STRUCTURE,0) = 1.000000; -NODES[5066](IS_STRUCTURE,0) = 1.000000; -NODES[5067](IS_STRUCTURE,0) = 1.000000; -NODES[5071](IS_STRUCTURE,0) = 1.000000; -NODES[5080](IS_STRUCTURE,0) = 1.000000; -NODES[5083](IS_STRUCTURE,0) = 1.000000; -NODES[5085](IS_STRUCTURE,0) = 1.000000; -NODES[5101](IS_STRUCTURE,0) = 1.000000; -NODES[5102](IS_STRUCTURE,0) = 1.000000; -NODES[5104](IS_STRUCTURE,0) = 1.000000; -NODES[5117](IS_STRUCTURE,0) = 1.000000; -NODES[5134](IS_STRUCTURE,0) = 1.000000; -NODES[5141](IS_STRUCTURE,0) = 1.000000; -NODES[5142](IS_STRUCTURE,0) = 1.000000; -NODES[5147](IS_STRUCTURE,0) = 1.000000; -NODES[5154](IS_STRUCTURE,0) = 1.000000; -NODES[5160](IS_STRUCTURE,0) = 1.000000; -NODES[5161](IS_STRUCTURE,0) = 1.000000; -NODES[5163](IS_STRUCTURE,0) = 1.000000; -NODES[5177](IS_STRUCTURE,0) = 1.000000; -NODES[5180](IS_STRUCTURE,0) = 1.000000; -NODES[5181](IS_STRUCTURE,0) = 1.000000; -NODES[5185](IS_STRUCTURE,0) = 1.000000; -NODES[5198](IS_STRUCTURE,0) = 1.000000; -NODES[5199](IS_STRUCTURE,0) = 1.000000; -NODES[5221](IS_STRUCTURE,0) = 1.000000; -NODES[5222](IS_STRUCTURE,0) = 1.000000; -NODES[5230](IS_STRUCTURE,0) = 1.000000; -NODES[5233](IS_STRUCTURE,0) = 1.000000; -NODES[5246](IS_STRUCTURE,0) = 1.000000; -NODES[5247](IS_STRUCTURE,0) = 1.000000; -NODES[5253](IS_STRUCTURE,0) = 1.000000; -NODES[5254](IS_STRUCTURE,0) = 1.000000; -NODES[5257](IS_STRUCTURE,0) = 1.000000; -NODES[5259](IS_STRUCTURE,0) = 1.000000; -NODES[5260](IS_STRUCTURE,0) = 1.000000; -NODES[5262](IS_STRUCTURE,0) = 1.000000; -NODES[5263](IS_STRUCTURE,0) = 1.000000; -NODES[5271](IS_STRUCTURE,0) = 1.000000; -NODES[5275](IS_STRUCTURE,0) = 1.000000; -NODES[5281](IS_STRUCTURE,0) = 1.000000; -NODES[5289](IS_STRUCTURE,0) = 1.000000; -NODES[5290](IS_STRUCTURE,0) = 1.000000; -NODES[5291](IS_STRUCTURE,0) = 1.000000; -NODES[5308](IS_STRUCTURE,0) = 1.000000; -NODES[5325](IS_STRUCTURE,0) = 1.000000; -NODES[5333](IS_STRUCTURE,0) = 1.000000; -NODES[5334](IS_STRUCTURE,0) = 1.000000; -NODES[5336](IS_STRUCTURE,0) = 1.000000; -NODES[5337](IS_STRUCTURE,0) = 1.000000; -NODES[5341](IS_STRUCTURE,0) = 1.000000; -NODES[5343](IS_STRUCTURE,0) = 1.000000; -NODES[5344](IS_STRUCTURE,0) = 1.000000; -NODES[5357](IS_STRUCTURE,0) = 1.000000; -NODES[5362](IS_STRUCTURE,0) = 1.000000; -NODES[5375](IS_STRUCTURE,0) = 1.000000; -NODES[5376](IS_STRUCTURE,0) = 1.000000; -NODES[5389](IS_STRUCTURE,0) = 1.000000; -NODES[5404](IS_STRUCTURE,0) = 1.000000; -NODES[5405](IS_STRUCTURE,0) = 1.000000; -NODES[5407](IS_STRUCTURE,0) = 1.000000; -NODES[5425](IS_STRUCTURE,0) = 1.000000; -NODES[5427](IS_STRUCTURE,0) = 1.000000; -NODES[5435](IS_STRUCTURE,0) = 1.000000; -NODES[5440](IS_STRUCTURE,0) = 1.000000; -NODES[5445](IS_STRUCTURE,0) = 1.000000; -NODES[5446](IS_STRUCTURE,0) = 1.000000; -NODES[5480](IS_STRUCTURE,0) = 1.000000; -NODES[5487](IS_STRUCTURE,0) = 1.000000; -NODES[5491](IS_STRUCTURE,0) = 1.000000; -NODES[5492](IS_STRUCTURE,0) = 1.000000; -NODES[5496](IS_STRUCTURE,0) = 1.000000; -NODES[5497](IS_STRUCTURE,0) = 1.000000; -NODES[5499](IS_STRUCTURE,0) = 1.000000; -NODES[5500](IS_STRUCTURE,0) = 1.000000; -NODES[5501](IS_STRUCTURE,0) = 1.000000; -NODES[5502](IS_STRUCTURE,0) = 1.000000; -NODES[5503](IS_STRUCTURE,0) = 1.000000; -NODES[5505](IS_STRUCTURE,0) = 1.000000; -NODES[5510](IS_STRUCTURE,0) = 1.000000; -NODES[5519](IS_STRUCTURE,0) = 1.000000; -NODES[5528](IS_STRUCTURE,0) = 1.000000; -NODES[5533](IS_STRUCTURE,0) = 1.000000; -NODES[5534](IS_STRUCTURE,0) = 1.000000; -NODES[5540](IS_STRUCTURE,0) = 1.000000; -NODES[5548](IS_STRUCTURE,0) = 1.000000; -NODES[5550](IS_STRUCTURE,0) = 1.000000; -NODES[5551](IS_STRUCTURE,0) = 1.000000; -NODES[5563](IS_STRUCTURE,0) = 1.000000; -NODES[5568](IS_STRUCTURE,0) = 1.000000; -NODES[5575](IS_STRUCTURE,0) = 1.000000; -NODES[5579](IS_STRUCTURE,0) = 1.000000; -NODES[5580](IS_STRUCTURE,0) = 1.000000; -NODES[5587](IS_STRUCTURE,0) = 1.000000; -NODES[5596](IS_STRUCTURE,0) = 1.000000; -NODES[5597](IS_STRUCTURE,0) = 1.000000; -NODES[5598](IS_STRUCTURE,0) = 1.000000; -NODES[5618](IS_STRUCTURE,0) = 1.000000; -NODES[5619](IS_STRUCTURE,0) = 1.000000; -NODES[5620](IS_STRUCTURE,0) = 1.000000; -NODES[5630](IS_STRUCTURE,0) = 1.000000; -NODES[5638](IS_STRUCTURE,0) = 1.000000; -NODES[5646](IS_STRUCTURE,0) = 1.000000; -NODES[5647](IS_STRUCTURE,0) = 1.000000; -NODES[5662](IS_STRUCTURE,0) = 1.000000; -NODES[5678](IS_STRUCTURE,0) = 1.000000; -NODES[5692](IS_STRUCTURE,0) = 1.000000; -NODES[5693](IS_STRUCTURE,0) = 1.000000; -NODES[5698](IS_STRUCTURE,0) = 1.000000; -NODES[5705](IS_STRUCTURE,0) = 1.000000; -NODES[5721](IS_STRUCTURE,0) = 1.000000; -NODES[5722](IS_STRUCTURE,0) = 1.000000; -NODES[5734](IS_STRUCTURE,0) = 1.000000; -NODES[5735](IS_STRUCTURE,0) = 1.000000; -NODES[5736](IS_STRUCTURE,0) = 1.000000; -NODES[5746](IS_STRUCTURE,0) = 1.000000; -NODES[5760](IS_STRUCTURE,0) = 1.000000; -NODES[5768](IS_STRUCTURE,0) = 1.000000; -NODES[5774](IS_STRUCTURE,0) = 1.000000; -NODES[5782](IS_STRUCTURE,0) = 1.000000; -NODES[5792](IS_STRUCTURE,0) = 1.000000; -NODES[5799](IS_STRUCTURE,0) = 1.000000; -NODES[5815](IS_STRUCTURE,0) = 1.000000; -NODES[5820](IS_STRUCTURE,0) = 1.000000; -NODES[5832](IS_STRUCTURE,0) = 1.000000; -NODES[5836](IS_STRUCTURE,0) = 1.000000; -NODES[5837](IS_STRUCTURE,0) = 1.000000; -NODES[5850](IS_STRUCTURE,0) = 1.000000; -NODES[5859](IS_STRUCTURE,0) = 1.000000; -NODES[5860](IS_STRUCTURE,0) = 1.000000; -NODES[5862](IS_STRUCTURE,0) = 1.000000; -NODES[5867](IS_STRUCTURE,0) = 1.000000; -NODES[5868](IS_STRUCTURE,0) = 1.000000; -NODES[5876](IS_STRUCTURE,0) = 1.000000; -NODES[5877](IS_STRUCTURE,0) = 1.000000; -NODES[5899](IS_STRUCTURE,0) = 1.000000; -NODES[5900](IS_STRUCTURE,0) = 1.000000; -NODES[5901](IS_STRUCTURE,0) = 1.000000; -NODES[5903](IS_STRUCTURE,0) = 1.000000; -NODES[5904](IS_STRUCTURE,0) = 1.000000; -NODES[5906](IS_STRUCTURE,0) = 1.000000; -NODES[5920](IS_STRUCTURE,0) = 1.000000; -NODES[5925](IS_STRUCTURE,0) = 1.000000; -NODES[5931](IS_STRUCTURE,0) = 1.000000; -NODES[5938](IS_STRUCTURE,0) = 1.000000; -NODES[5939](IS_STRUCTURE,0) = 1.000000; -NODES[5946](IS_STRUCTURE,0) = 1.000000; -NODES[5960](IS_STRUCTURE,0) = 1.000000; -NODES[5961](IS_STRUCTURE,0) = 1.000000; -NODES[5962](IS_STRUCTURE,0) = 1.000000; -NODES[5964](IS_STRUCTURE,0) = 1.000000; -NODES[5972](IS_STRUCTURE,0) = 1.000000; -NODES[5987](IS_STRUCTURE,0) = 1.000000; -NODES[5988](IS_STRUCTURE,0) = 1.000000; -NODES[6016](IS_STRUCTURE,0) = 1.000000; -NODES[6025](IS_STRUCTURE,0) = 1.000000; -NODES[6026](IS_STRUCTURE,0) = 1.000000; -NODES[6033](IS_STRUCTURE,0) = 1.000000; -NODES[6036](IS_STRUCTURE,0) = 1.000000; -NODES[6041](IS_STRUCTURE,0) = 1.000000; -NODES[6045](IS_STRUCTURE,0) = 1.000000; -NODES[6054](IS_STRUCTURE,0) = 1.000000; -NODES[6056](IS_STRUCTURE,0) = 1.000000; -NODES[6057](IS_STRUCTURE,0) = 1.000000; -NODES[6070](IS_STRUCTURE,0) = 1.000000; -NODES[6071](IS_STRUCTURE,0) = 1.000000; -NODES[6074](IS_STRUCTURE,0) = 1.000000; -NODES[6077](IS_STRUCTURE,0) = 1.000000; -NODES[6085](IS_STRUCTURE,0) = 1.000000; -NODES[6089](IS_STRUCTURE,0) = 1.000000; -NODES[6095](IS_STRUCTURE,0) = 1.000000; -NODES[6096](IS_STRUCTURE,0) = 1.000000; -NODES[6107](IS_STRUCTURE,0) = 1.000000; -NODES[6108](IS_STRUCTURE,0) = 1.000000; -NODES[6122](IS_STRUCTURE,0) = 1.000000; -NODES[6124](IS_STRUCTURE,0) = 1.000000; -NODES[6128](IS_STRUCTURE,0) = 1.000000; -NODES[6129](IS_STRUCTURE,0) = 1.000000; -NODES[6135](IS_STRUCTURE,0) = 1.000000; -NODES[6136](IS_STRUCTURE,0) = 1.000000; -NODES[6145](IS_STRUCTURE,0) = 1.000000; -NODES[6154](IS_STRUCTURE,0) = 1.000000; -NODES[6155](IS_STRUCTURE,0) = 1.000000; -NODES[6175](IS_STRUCTURE,0) = 1.000000; -NODES[6176](IS_STRUCTURE,0) = 1.000000; -NODES[6195](IS_STRUCTURE,0) = 1.000000; -NODES[6205](IS_STRUCTURE,0) = 1.000000; -NODES[6209](IS_STRUCTURE,0) = 1.000000; -NODES[6241](IS_STRUCTURE,0) = 1.000000; -NODES[6242](IS_STRUCTURE,0) = 1.000000; -NODES[6246](IS_STRUCTURE,0) = 1.000000; -NODES[6252](IS_STRUCTURE,0) = 1.000000; -NODES[6267](IS_STRUCTURE,0) = 1.000000; -NODES[6275](IS_STRUCTURE,0) = 1.000000; -NODES[6276](IS_STRUCTURE,0) = 1.000000; -NODES[6279](IS_STRUCTURE,0) = 1.000000; -NODES[6280](IS_STRUCTURE,0) = 1.000000; -NODES[6288](IS_STRUCTURE,0) = 1.000000; -NODES[6289](IS_STRUCTURE,0) = 1.000000; -NODES[6290](IS_STRUCTURE,0) = 1.000000; -NODES[6291](IS_STRUCTURE,0) = 1.000000; -NODES[6293](IS_STRUCTURE,0) = 1.000000; -NODES[6309](IS_STRUCTURE,0) = 1.000000; -NODES[6310](IS_STRUCTURE,0) = 1.000000; -NODES[6322](IS_STRUCTURE,0) = 1.000000; -NODES[6323](IS_STRUCTURE,0) = 1.000000; -NODES[6324](IS_STRUCTURE,0) = 1.000000; -NODES[6325](IS_STRUCTURE,0) = 1.000000; -NODES[6326](IS_STRUCTURE,0) = 1.000000; -NODES[6327](IS_STRUCTURE,0) = 1.000000; -NODES[6328](IS_STRUCTURE,0) = 1.000000; -NODES[6343](IS_STRUCTURE,0) = 1.000000; -NODES[6344](IS_STRUCTURE,0) = 1.000000; -NODES[6356](IS_STRUCTURE,0) = 1.000000; -NODES[6357](IS_STRUCTURE,0) = 1.000000; -NODES[6358](IS_STRUCTURE,0) = 1.000000; -NODES[6359](IS_STRUCTURE,0) = 1.000000; -NODES[6377](IS_STRUCTURE,0) = 1.000000; -NODES[6378](IS_STRUCTURE,0) = 1.000000; -NODES[6379](IS_STRUCTURE,0) = 1.000000; -NODES[6380](IS_STRUCTURE,0) = 1.000000; -NODES[6381](IS_STRUCTURE,0) = 1.000000; -NODES[6382](IS_STRUCTURE,0) = 1.000000; -NODES[6384](IS_STRUCTURE,0) = 1.000000; -NODES[6385](IS_STRUCTURE,0) = 1.000000; -NODES[6392](IS_STRUCTURE,0) = 1.000000; -NODES[6398](IS_STRUCTURE,0) = 1.000000; -NODES[6400](IS_STRUCTURE,0) = 1.000000; -NODES[6408](IS_STRUCTURE,0) = 1.000000; -NODES[6409](IS_STRUCTURE,0) = 1.000000; -NODES[6410](IS_STRUCTURE,0) = 1.000000; -NODES[6420](IS_STRUCTURE,0) = 1.000000; -NODES[6422](IS_STRUCTURE,0) = 1.000000; -NODES[6423](IS_STRUCTURE,0) = 1.000000; -NODES[6424](IS_STRUCTURE,0) = 1.000000; -NODES[6425](IS_STRUCTURE,0) = 1.000000; -NODES[6426](IS_STRUCTURE,0) = 1.000000; -NODES[6434](IS_STRUCTURE,0) = 1.000000; -NODES[6435](IS_STRUCTURE,0) = 1.000000; -NODES[6436](IS_STRUCTURE,0) = 1.000000; -NODES[6439](IS_STRUCTURE,0) = 1.000000; -NODES[6440](IS_STRUCTURE,0) = 1.000000; -NODES[6451](IS_STRUCTURE,0) = 1.000000; -NODES[6452](IS_STRUCTURE,0) = 1.000000; -NODES[6453](IS_STRUCTURE,0) = 1.000000; -NODES[6454](IS_STRUCTURE,0) = 1.000000; -NODES[6455](IS_STRUCTURE,0) = 1.000000; -NODES[6469](IS_STRUCTURE,0) = 1.000000; -NODES[6470](IS_STRUCTURE,0) = 1.000000; -NODES[6473](IS_STRUCTURE,0) = 1.000000; -NODES[6474](IS_STRUCTURE,0) = 1.000000; -NODES[6478](IS_STRUCTURE,0) = 1.000000; -NODES[6482](IS_STRUCTURE,0) = 1.000000; -NODES[6484](IS_STRUCTURE,0) = 1.000000; -NODES[6485](IS_STRUCTURE,0) = 1.000000; -NODES[6486](IS_STRUCTURE,0) = 1.000000; -NODES[6487](IS_STRUCTURE,0) = 1.000000; -NODES[6499](IS_STRUCTURE,0) = 1.000000; -NODES[6502](IS_STRUCTURE,0) = 1.000000; -NODES[6506](IS_STRUCTURE,0) = 1.000000; -NODES[6507](IS_STRUCTURE,0) = 1.000000; -NODES[6508](IS_STRUCTURE,0) = 1.000000; -NODES[6511](IS_STRUCTURE,0) = 1.000000; -NODES[6529](IS_STRUCTURE,0) = 1.000000; -NODES[6544](IS_STRUCTURE,0) = 1.000000; -NODES[6545](IS_STRUCTURE,0) = 1.000000; -NODES[6546](IS_STRUCTURE,0) = 1.000000; -NODES[6547](IS_STRUCTURE,0) = 1.000000; -NODES[6548](IS_STRUCTURE,0) = 1.000000; -NODES[6549](IS_STRUCTURE,0) = 1.000000; -NODES[6550](IS_STRUCTURE,0) = 1.000000; -NODES[6561](IS_STRUCTURE,0) = 1.000000; -NODES[6569](IS_STRUCTURE,0) = 1.000000; -NODES[6570](IS_STRUCTURE,0) = 1.000000; -NODES[6573](IS_STRUCTURE,0) = 1.000000; -NODES[6577](IS_STRUCTURE,0) = 1.000000; -NODES[6578](IS_STRUCTURE,0) = 1.000000; -NODES[6579](IS_STRUCTURE,0) = 1.000000; -NODES[6582](IS_STRUCTURE,0) = 1.000000; -NODES[6593](IS_STRUCTURE,0) = 1.000000; -NODES[6594](IS_STRUCTURE,0) = 1.000000; -NODES[6595](IS_STRUCTURE,0) = 1.000000; -NODES[6596](IS_STRUCTURE,0) = 1.000000; -NODES[6597](IS_STRUCTURE,0) = 1.000000; -NODES[6598](IS_STRUCTURE,0) = 1.000000; -NODES[6603](IS_STRUCTURE,0) = 1.000000; -NODES[6607](IS_STRUCTURE,0) = 1.000000; -NODES[6609](IS_STRUCTURE,0) = 1.000000; -NODES[6610](IS_STRUCTURE,0) = 1.000000; -NODES[6620](IS_STRUCTURE,0) = 1.000000; -NODES[6621](IS_STRUCTURE,0) = 1.000000; -NODES[6622](IS_STRUCTURE,0) = 1.000000; -NODES[6623](IS_STRUCTURE,0) = 1.000000; -NODES[6632](IS_STRUCTURE,0) = 1.000000; -NODES[6635](IS_STRUCTURE,0) = 1.000000; -NODES[6640](IS_STRUCTURE,0) = 1.000000; -NODES[6648](IS_STRUCTURE,0) = 1.000000; -NODES[6649](IS_STRUCTURE,0) = 1.000000; -NODES[6651](IS_STRUCTURE,0) = 1.000000; -NODES[6658](IS_STRUCTURE,0) = 1.000000; -NODES[6663](IS_STRUCTURE,0) = 1.000000; -NODES[6665](IS_STRUCTURE,0) = 1.000000; -NODES[6666](IS_STRUCTURE,0) = 1.000000; -NODES[6673](IS_STRUCTURE,0) = 1.000000; -NODES[6674](IS_STRUCTURE,0) = 1.000000; -NODES[6681](IS_STRUCTURE,0) = 1.000000; -NODES[6683](IS_STRUCTURE,0) = 1.000000; -NODES[6684](IS_STRUCTURE,0) = 1.000000; -NODES[6685](IS_STRUCTURE,0) = 1.000000; -NODES[6686](IS_STRUCTURE,0) = 1.000000; -NODES[6687](IS_STRUCTURE,0) = 1.000000; -NODES[6695](IS_STRUCTURE,0) = 1.000000; -NODES[6699](IS_STRUCTURE,0) = 1.000000; -NODES[6700](IS_STRUCTURE,0) = 1.000000; -NODES[6701](IS_STRUCTURE,0) = 1.000000; -NODES[6702](IS_STRUCTURE,0) = 1.000000; -NODES[6703](IS_STRUCTURE,0) = 1.000000; -NODES[6704](IS_STRUCTURE,0) = 1.000000; -NODES[6705](IS_STRUCTURE,0) = 1.000000; -NODES[6712](IS_STRUCTURE,0) = 1.000000; -NODES[6716](IS_STRUCTURE,0) = 1.000000; -NODES[6717](IS_STRUCTURE,0) = 1.000000; -NODES[6727](IS_STRUCTURE,0) = 1.000000; -NODES[6731](IS_STRUCTURE,0) = 1.000000; -NODES[6732](IS_STRUCTURE,0) = 1.000000; -NODES[6733](IS_STRUCTURE,0) = 1.000000; -NODES[6734](IS_STRUCTURE,0) = 1.000000; -NODES[6735](IS_STRUCTURE,0) = 1.000000; -NODES[6743](IS_STRUCTURE,0) = 1.000000; -NODES[6752](IS_STRUCTURE,0) = 1.000000; -NODES[6753](IS_STRUCTURE,0) = 1.000000; -NODES[6760](IS_STRUCTURE,0) = 1.000000; -NODES[6769](IS_STRUCTURE,0) = 1.000000; -NODES[6774](IS_STRUCTURE,0) = 1.000000; -NODES[6775](IS_STRUCTURE,0) = 1.000000; -NODES[6782](IS_STRUCTURE,0) = 1.000000; -NODES[6783](IS_STRUCTURE,0) = 1.000000; -NODES[6784](IS_STRUCTURE,0) = 1.000000; -NODES[6785](IS_STRUCTURE,0) = 1.000000; -NODES[6786](IS_STRUCTURE,0) = 1.000000; -NODES[6787](IS_STRUCTURE,0) = 1.000000; -NODES[6820](IS_STRUCTURE,0) = 1.000000; -NODES[6827](IS_STRUCTURE,0) = 1.000000; -NODES[6831](IS_STRUCTURE,0) = 1.000000; -NODES[6833](IS_STRUCTURE,0) = 1.000000; -NODES[6834](IS_STRUCTURE,0) = 1.000000; -NODES[6837](IS_STRUCTURE,0) = 1.000000; -NODES[6840](IS_STRUCTURE,0) = 1.000000; -NODES[6843](IS_STRUCTURE,0) = 1.000000; -NODES[6844](IS_STRUCTURE,0) = 1.000000; -NODES[6845](IS_STRUCTURE,0) = 1.000000; -NODES[6846](IS_STRUCTURE,0) = 1.000000; -NODES[6847](IS_STRUCTURE,0) = 1.000000; -NODES[6848](IS_STRUCTURE,0) = 1.000000; -NODES[6849](IS_STRUCTURE,0) = 1.000000; -NODES[6850](IS_STRUCTURE,0) = 1.000000; -NODES[6851](IS_STRUCTURE,0) = 1.000000; -NODES[6852](IS_STRUCTURE,0) = 1.000000; -NODES[6857](IS_STRUCTURE,0) = 1.000000; -NODES[6858](IS_STRUCTURE,0) = 1.000000; -NODES[6865](IS_STRUCTURE,0) = 1.000000; -NODES[6866](IS_STRUCTURE,0) = 1.000000; -NODES[6870](IS_STRUCTURE,0) = 1.000000; -NODES[6876](IS_STRUCTURE,0) = 1.000000; -NODES[6877](IS_STRUCTURE,0) = 1.000000; -NODES[6880](IS_STRUCTURE,0) = 1.000000; -NODES[6881](IS_STRUCTURE,0) = 1.000000; -NODES[6882](IS_STRUCTURE,0) = 1.000000; -NODES[6883](IS_STRUCTURE,0) = 1.000000; -NODES[6884](IS_STRUCTURE,0) = 1.000000; -NODES[6903](IS_STRUCTURE,0) = 1.000000; -NODES[6907](IS_STRUCTURE,0) = 1.000000; -NODES[6913](IS_STRUCTURE,0) = 1.000000; -NODES[6922](IS_STRUCTURE,0) = 1.000000; -NODES[6929](IS_STRUCTURE,0) = 1.000000; -NODES[6930](IS_STRUCTURE,0) = 1.000000; -NODES[6931](IS_STRUCTURE,0) = 1.000000; -NODES[6932](IS_STRUCTURE,0) = 1.000000; -NODES[6948](IS_STRUCTURE,0) = 1.000000; -NODES[6961](IS_STRUCTURE,0) = 1.000000; -NODES[6962](IS_STRUCTURE,0) = 1.000000; -NODES[6963](IS_STRUCTURE,0) = 1.000000; -NODES[6972](IS_STRUCTURE,0) = 1.000000; -NODES[6973](IS_STRUCTURE,0) = 1.000000; -NODES[6974](IS_STRUCTURE,0) = 1.000000; -NODES[6975](IS_STRUCTURE,0) = 1.000000; -NODES[6983](IS_STRUCTURE,0) = 1.000000; -NODES[6990](IS_STRUCTURE,0) = 1.000000; -NODES[6996](IS_STRUCTURE,0) = 1.000000; -NODES[7001](IS_STRUCTURE,0) = 1.000000; -NODES[7002](IS_STRUCTURE,0) = 1.000000; -NODES[7003](IS_STRUCTURE,0) = 1.000000; -NODES[7004](IS_STRUCTURE,0) = 1.000000; -NODES[7006](IS_STRUCTURE,0) = 1.000000; -NODES[7008](IS_STRUCTURE,0) = 1.000000; -NODES[7009](IS_STRUCTURE,0) = 1.000000; -NODES[7012](IS_STRUCTURE,0) = 1.000000; -NODES[7017](IS_STRUCTURE,0) = 1.000000; -NODES[7018](IS_STRUCTURE,0) = 1.000000; -NODES[7019](IS_STRUCTURE,0) = 1.000000; -NODES[7020](IS_STRUCTURE,0) = 1.000000; -NODES[7021](IS_STRUCTURE,0) = 1.000000; -NODES[7029](IS_STRUCTURE,0) = 1.000000; -NODES[7033](IS_STRUCTURE,0) = 1.000000; -NODES[7039](IS_STRUCTURE,0) = 1.000000; -NODES[7044](IS_STRUCTURE,0) = 1.000000; -NODES[7045](IS_STRUCTURE,0) = 1.000000; -NODES[7046](IS_STRUCTURE,0) = 1.000000; -NODES[7047](IS_STRUCTURE,0) = 1.000000; -NODES[7048](IS_STRUCTURE,0) = 1.000000; -NODES[7049](IS_STRUCTURE,0) = 1.000000; -NODES[7060](IS_STRUCTURE,0) = 1.000000; -NODES[7066](IS_STRUCTURE,0) = 1.000000; -NODES[7070](IS_STRUCTURE,0) = 1.000000; -NODES[7075](IS_STRUCTURE,0) = 1.000000; -NODES[7080](IS_STRUCTURE,0) = 1.000000; -NODES[7083](IS_STRUCTURE,0) = 1.000000; -NODES[7084](IS_STRUCTURE,0) = 1.000000; -NODES[7099](IS_STRUCTURE,0) = 1.000000; -NODES[7100](IS_STRUCTURE,0) = 1.000000; -NODES[7101](IS_STRUCTURE,0) = 1.000000; -NODES[7102](IS_STRUCTURE,0) = 1.000000; -NODES[7103](IS_STRUCTURE,0) = 1.000000; -NODES[7108](IS_STRUCTURE,0) = 1.000000; -NODES[7125](IS_STRUCTURE,0) = 1.000000; -NODES[7131](IS_STRUCTURE,0) = 1.000000; -NODES[7136](IS_STRUCTURE,0) = 1.000000; -NODES[7137](IS_STRUCTURE,0) = 1.000000; -NODES[7138](IS_STRUCTURE,0) = 1.000000; -NODES[7144](IS_STRUCTURE,0) = 1.000000; -NODES[7145](IS_STRUCTURE,0) = 1.000000; -NODES[7160](IS_STRUCTURE,0) = 1.000000; -NODES[7162](IS_STRUCTURE,0) = 1.000000; -NODES[7168](IS_STRUCTURE,0) = 1.000000; -NODES[7173](IS_STRUCTURE,0) = 1.000000; -NODES[7174](IS_STRUCTURE,0) = 1.000000; -NODES[7175](IS_STRUCTURE,0) = 1.000000; -NODES[7176](IS_STRUCTURE,0) = 1.000000; -NODES[7177](IS_STRUCTURE,0) = 1.000000; -NODES[7179](IS_STRUCTURE,0) = 1.000000; -NODES[7183](IS_STRUCTURE,0) = 1.000000; -NODES[7186](IS_STRUCTURE,0) = 1.000000; -NODES[7187](IS_STRUCTURE,0) = 1.000000; -NODES[7203](IS_STRUCTURE,0) = 1.000000; -NODES[7204](IS_STRUCTURE,0) = 1.000000; -NODES[7205](IS_STRUCTURE,0) = 1.000000; -NODES[7206](IS_STRUCTURE,0) = 1.000000; -NODES[7207](IS_STRUCTURE,0) = 1.000000; -NODES[7229](IS_STRUCTURE,0) = 1.000000; -NODES[7232](IS_STRUCTURE,0) = 1.000000; -NODES[7239](IS_STRUCTURE,0) = 1.000000; -NODES[7245](IS_STRUCTURE,0) = 1.000000; -NODES[7246](IS_STRUCTURE,0) = 1.000000; -NODES[7247](IS_STRUCTURE,0) = 1.000000; -NODES[7248](IS_STRUCTURE,0) = 1.000000; -NODES[7251](IS_STRUCTURE,0) = 1.000000; -NODES[7255](IS_STRUCTURE,0) = 1.000000; -NODES[7256](IS_STRUCTURE,0) = 1.000000; -NODES[7261](IS_STRUCTURE,0) = 1.000000; -NODES[7276](IS_STRUCTURE,0) = 1.000000; -NODES[7281](IS_STRUCTURE,0) = 1.000000; -NODES[7282](IS_STRUCTURE,0) = 1.000000; -NODES[7301](IS_STRUCTURE,0) = 1.000000; -NODES[7321](IS_STRUCTURE,0) = 1.000000; -NODES[7322](IS_STRUCTURE,0) = 1.000000; -NODES[7323](IS_STRUCTURE,0) = 1.000000; -NODES[7324](IS_STRUCTURE,0) = 1.000000; -NODES[7325](IS_STRUCTURE,0) = 1.000000; -NODES[7327](IS_STRUCTURE,0) = 1.000000; -NODES[7331](IS_STRUCTURE,0) = 1.000000; -NODES[7334](IS_STRUCTURE,0) = 1.000000; -NODES[7335](IS_STRUCTURE,0) = 1.000000; -NODES[7338](IS_STRUCTURE,0) = 1.000000; -NODES[7345](IS_STRUCTURE,0) = 1.000000; -NODES[7349](IS_STRUCTURE,0) = 1.000000; -NODES[7350](IS_STRUCTURE,0) = 1.000000; -NODES[7361](IS_STRUCTURE,0) = 1.000000; -NODES[7366](IS_STRUCTURE,0) = 1.000000; -NODES[7369](IS_STRUCTURE,0) = 1.000000; -NODES[7370](IS_STRUCTURE,0) = 1.000000; -NODES[7380](IS_STRUCTURE,0) = 1.000000; -NODES[7383](IS_STRUCTURE,0) = 1.000000; -NODES[7384](IS_STRUCTURE,0) = 1.000000; -NODES[7386](IS_STRUCTURE,0) = 1.000000; -NODES[7388](IS_STRUCTURE,0) = 1.000000; -NODES[7389](IS_STRUCTURE,0) = 1.000000; -NODES[7394](IS_STRUCTURE,0) = 1.000000; -NODES[7397](IS_STRUCTURE,0) = 1.000000; -NODES[7398](IS_STRUCTURE,0) = 1.000000; -NODES[7399](IS_STRUCTURE,0) = 1.000000; -NODES[7400](IS_STRUCTURE,0) = 1.000000; -NODES[7404](IS_STRUCTURE,0) = 1.000000; -NODES[7405](IS_STRUCTURE,0) = 1.000000; -NODES[7412](IS_STRUCTURE,0) = 1.000000; -NODES[7414](IS_STRUCTURE,0) = 1.000000; -NODES[7415](IS_STRUCTURE,0) = 1.000000; -NODES[7423](IS_STRUCTURE,0) = 1.000000; -NODES[7430](IS_STRUCTURE,0) = 1.000000; -NODES[7434](IS_STRUCTURE,0) = 1.000000; -NODES[7435](IS_STRUCTURE,0) = 1.000000; -NODES[7436](IS_STRUCTURE,0) = 1.000000; -NODES[7437](IS_STRUCTURE,0) = 1.000000; -NODES[7438](IS_STRUCTURE,0) = 1.000000; -NODES[7439](IS_STRUCTURE,0) = 1.000000; -NODES[7440](IS_STRUCTURE,0) = 1.000000; -NODES[7441](IS_STRUCTURE,0) = 1.000000; -NODES[7444](IS_STRUCTURE,0) = 1.000000; -NODES[7449](IS_STRUCTURE,0) = 1.000000; -NODES[7453](IS_STRUCTURE,0) = 1.000000; -NODES[7455](IS_STRUCTURE,0) = 1.000000; -NODES[7462](IS_STRUCTURE,0) = 1.000000; -NODES[7463](IS_STRUCTURE,0) = 1.000000; -NODES[7464](IS_STRUCTURE,0) = 1.000000; -NODES[7469](IS_STRUCTURE,0) = 1.000000; -NODES[7473](IS_STRUCTURE,0) = 1.000000; -NODES[7474](IS_STRUCTURE,0) = 1.000000; -NODES[7476](IS_STRUCTURE,0) = 1.000000; -NODES[7479](IS_STRUCTURE,0) = 1.000000; -NODES[7480](IS_STRUCTURE,0) = 1.000000; -NODES[7481](IS_STRUCTURE,0) = 1.000000; -NODES[7503](IS_STRUCTURE,0) = 1.000000; -NODES[7504](IS_STRUCTURE,0) = 1.000000; -NODES[7506](IS_STRUCTURE,0) = 1.000000; -NODES[7518](IS_STRUCTURE,0) = 1.000000; -NODES[7521](IS_STRUCTURE,0) = 1.000000; -NODES[7522](IS_STRUCTURE,0) = 1.000000; -NODES[7527](IS_STRUCTURE,0) = 1.000000; -NODES[7528](IS_STRUCTURE,0) = 1.000000; -NODES[7530](IS_STRUCTURE,0) = 1.000000; -NODES[7531](IS_STRUCTURE,0) = 1.000000; -NODES[7533](IS_STRUCTURE,0) = 1.000000; -NODES[7534](IS_STRUCTURE,0) = 1.000000; -NODES[7546](IS_STRUCTURE,0) = 1.000000; -NODES[7547](IS_STRUCTURE,0) = 1.000000; -NODES[7548](IS_STRUCTURE,0) = 1.000000; -NODES[7549](IS_STRUCTURE,0) = 1.000000; -NODES[7552](IS_STRUCTURE,0) = 1.000000; -NODES[7561](IS_STRUCTURE,0) = 1.000000; -NODES[7562](IS_STRUCTURE,0) = 1.000000; -NODES[7563](IS_STRUCTURE,0) = 1.000000; -NODES[7564](IS_STRUCTURE,0) = 1.000000; -NODES[7565](IS_STRUCTURE,0) = 1.000000; -NODES[7570](IS_STRUCTURE,0) = 1.000000; -NODES[7575](IS_STRUCTURE,0) = 1.000000; -NODES[7576](IS_STRUCTURE,0) = 1.000000; -NODES[7577](IS_STRUCTURE,0) = 1.000000; -NODES[7592](IS_STRUCTURE,0) = 1.000000; -NODES[7596](IS_STRUCTURE,0) = 1.000000; -NODES[7620](IS_STRUCTURE,0) = 1.000000; -NODES[7625](IS_STRUCTURE,0) = 1.000000; -NODES[7630](IS_STRUCTURE,0) = 1.000000; -NODES[7631](IS_STRUCTURE,0) = 1.000000; -NODES[7636](IS_STRUCTURE,0) = 1.000000; -NODES[7637](IS_STRUCTURE,0) = 1.000000; -NODES[7638](IS_STRUCTURE,0) = 1.000000; -NODES[7642](IS_STRUCTURE,0) = 1.000000; -NODES[7643](IS_STRUCTURE,0) = 1.000000; -NODES[7645](IS_STRUCTURE,0) = 1.000000; -NODES[7646](IS_STRUCTURE,0) = 1.000000; -NODES[7654](IS_STRUCTURE,0) = 1.000000; -NODES[7656](IS_STRUCTURE,0) = 1.000000; -NODES[7660](IS_STRUCTURE,0) = 1.000000; -NODES[7670](IS_STRUCTURE,0) = 1.000000; -NODES[7683](IS_STRUCTURE,0) = 1.000000; -NODES[7684](IS_STRUCTURE,0) = 1.000000; -NODES[7685](IS_STRUCTURE,0) = 1.000000; -NODES[7686](IS_STRUCTURE,0) = 1.000000; -NODES[7687](IS_STRUCTURE,0) = 1.000000; -NODES[7688](IS_STRUCTURE,0) = 1.000000; -NODES[7689](IS_STRUCTURE,0) = 1.000000; -NODES[7694](IS_STRUCTURE,0) = 1.000000; -NODES[7695](IS_STRUCTURE,0) = 1.000000; -NODES[7697](IS_STRUCTURE,0) = 1.000000; -NODES[7700](IS_STRUCTURE,0) = 1.000000; -NODES[7702](IS_STRUCTURE,0) = 1.000000; -NODES[7708](IS_STRUCTURE,0) = 1.000000; -NODES[7709](IS_STRUCTURE,0) = 1.000000; -NODES[7710](IS_STRUCTURE,0) = 1.000000; -NODES[7718](IS_STRUCTURE,0) = 1.000000; -NODES[7729](IS_STRUCTURE,0) = 1.000000; -NODES[7735](IS_STRUCTURE,0) = 1.000000; -NODES[7736](IS_STRUCTURE,0) = 1.000000; -NODES[7738](IS_STRUCTURE,0) = 1.000000; -NODES[7739](IS_STRUCTURE,0) = 1.000000; -NODES[7748](IS_STRUCTURE,0) = 1.000000; -NODES[7751](IS_STRUCTURE,0) = 1.000000; -NODES[7752](IS_STRUCTURE,0) = 1.000000; -NODES[7758](IS_STRUCTURE,0) = 1.000000; -NODES[7759](IS_STRUCTURE,0) = 1.000000; -NODES[7765](IS_STRUCTURE,0) = 1.000000; -NODES[7766](IS_STRUCTURE,0) = 1.000000; -NODES[7770](IS_STRUCTURE,0) = 1.000000; -NODES[7774](IS_STRUCTURE,0) = 1.000000; -NODES[7782](IS_STRUCTURE,0) = 1.000000; -NODES[7792](IS_STRUCTURE,0) = 1.000000; -NODES[7793](IS_STRUCTURE,0) = 1.000000; -NODES[7796](IS_STRUCTURE,0) = 1.000000; -NODES[7797](IS_STRUCTURE,0) = 1.000000; -NODES[7798](IS_STRUCTURE,0) = 1.000000; -NODES[7799](IS_STRUCTURE,0) = 1.000000; -NODES[7800](IS_STRUCTURE,0) = 1.000000; -NODES[7801](IS_STRUCTURE,0) = 1.000000; -NODES[7802](IS_STRUCTURE,0) = 1.000000; -NODES[7816](IS_STRUCTURE,0) = 1.000000; -NODES[7824](IS_STRUCTURE,0) = 1.000000; -NODES[7830](IS_STRUCTURE,0) = 1.000000; -NODES[7834](IS_STRUCTURE,0) = 1.000000; -NODES[7835](IS_STRUCTURE,0) = 1.000000; -NODES[7846](IS_STRUCTURE,0) = 1.000000; -NODES[7857](IS_STRUCTURE,0) = 1.000000; -NODES[7859](IS_STRUCTURE,0) = 1.000000; -NODES[7865](IS_STRUCTURE,0) = 1.000000; -NODES[7876](IS_STRUCTURE,0) = 1.000000; -NODES[7877](IS_STRUCTURE,0) = 1.000000; -NODES[7878](IS_STRUCTURE,0) = 1.000000; -NODES[7879](IS_STRUCTURE,0) = 1.000000; -NODES[7884](IS_STRUCTURE,0) = 1.000000; -NODES[7885](IS_STRUCTURE,0) = 1.000000; -NODES[7891](IS_STRUCTURE,0) = 1.000000; -NODES[7896](IS_STRUCTURE,0) = 1.000000; -NODES[7901](IS_STRUCTURE,0) = 1.000000; -NODES[7902](IS_STRUCTURE,0) = 1.000000; -NODES[7906](IS_STRUCTURE,0) = 1.000000; -NODES[7913](IS_STRUCTURE,0) = 1.000000; -NODES[7915](IS_STRUCTURE,0) = 1.000000; -NODES[7933](IS_STRUCTURE,0) = 1.000000; -NODES[7945](IS_STRUCTURE,0) = 1.000000; -NODES[7946](IS_STRUCTURE,0) = 1.000000; -NODES[7947](IS_STRUCTURE,0) = 1.000000; -NODES[7948](IS_STRUCTURE,0) = 1.000000; -NODES[7949](IS_STRUCTURE,0) = 1.000000; -NODES[7956](IS_STRUCTURE,0) = 1.000000; -NODES[7963](IS_STRUCTURE,0) = 1.000000; -NODES[7964](IS_STRUCTURE,0) = 1.000000; -NODES[7986](IS_STRUCTURE,0) = 1.000000; -NODES[7987](IS_STRUCTURE,0) = 1.000000; -NODES[7988](IS_STRUCTURE,0) = 1.000000; -NODES[7989](IS_STRUCTURE,0) = 1.000000; -NODES[7999](IS_STRUCTURE,0) = 1.000000; -NODES[8003](IS_STRUCTURE,0) = 1.000000; -NODES[8004](IS_STRUCTURE,0) = 1.000000; -NODES[8005](IS_STRUCTURE,0) = 1.000000; -NODES[8008](IS_STRUCTURE,0) = 1.000000; -NODES[8011](IS_STRUCTURE,0) = 1.000000; -NODES[8016](IS_STRUCTURE,0) = 1.000000; -NODES[8025](IS_STRUCTURE,0) = 1.000000; -NODES[8026](IS_STRUCTURE,0) = 1.000000; -NODES[8031](IS_STRUCTURE,0) = 1.000000; -NODES[8037](IS_STRUCTURE,0) = 1.000000; -NODES[8038](IS_STRUCTURE,0) = 1.000000; -NODES[8039](IS_STRUCTURE,0) = 1.000000; -NODES[8040](IS_STRUCTURE,0) = 1.000000; -NODES[8041](IS_STRUCTURE,0) = 1.000000; -NODES[8047](IS_STRUCTURE,0) = 1.000000; -NODES[8059](IS_STRUCTURE,0) = 1.000000; -NODES[8060](IS_STRUCTURE,0) = 1.000000; -NODES[8061](IS_STRUCTURE,0) = 1.000000; -NODES[8077](IS_STRUCTURE,0) = 1.000000; -NODES[8086](IS_STRUCTURE,0) = 1.000000; -NODES[8087](IS_STRUCTURE,0) = 1.000000; -NODES[8088](IS_STRUCTURE,0) = 1.000000; -NODES[8092](IS_STRUCTURE,0) = 1.000000; -NODES[8099](IS_STRUCTURE,0) = 1.000000; -NODES[8100](IS_STRUCTURE,0) = 1.000000; -NODES[8101](IS_STRUCTURE,0) = 1.000000; -NODES[8107](IS_STRUCTURE,0) = 1.000000; -NODES[8108](IS_STRUCTURE,0) = 1.000000; -NODES[8113](IS_STRUCTURE,0) = 1.000000; -NODES[8118](IS_STRUCTURE,0) = 1.000000; -NODES[8119](IS_STRUCTURE,0) = 1.000000; -NODES[8123](IS_STRUCTURE,0) = 1.000000; -NODES[8126](IS_STRUCTURE,0) = 1.000000; -NODES[8127](IS_STRUCTURE,0) = 1.000000; -NODES[8129](IS_STRUCTURE,0) = 1.000000; -NODES[8130](IS_STRUCTURE,0) = 1.000000; -NODES[8131](IS_STRUCTURE,0) = 1.000000; -NODES[8135](IS_STRUCTURE,0) = 1.000000; -NODES[8145](IS_STRUCTURE,0) = 1.000000; -NODES[8146](IS_STRUCTURE,0) = 1.000000; -NODES[8150](IS_STRUCTURE,0) = 1.000000; -NODES[8159](IS_STRUCTURE,0) = 1.000000; -NODES[8167](IS_STRUCTURE,0) = 1.000000; -NODES[8168](IS_STRUCTURE,0) = 1.000000; -NODES[8171](IS_STRUCTURE,0) = 1.000000; -NODES[8172](IS_STRUCTURE,0) = 1.000000; -NODES[8173](IS_STRUCTURE,0) = 1.000000; -NODES[8175](IS_STRUCTURE,0) = 1.000000; -NODES[8177](IS_STRUCTURE,0) = 1.000000; -NODES[8179](IS_STRUCTURE,0) = 1.000000; -NODES[8183](IS_STRUCTURE,0) = 1.000000; -NODES[8186](IS_STRUCTURE,0) = 1.000000; -NODES[8191](IS_STRUCTURE,0) = 1.000000; -NODES[8200](IS_STRUCTURE,0) = 1.000000; -NODES[8214](IS_STRUCTURE,0) = 1.000000; -NODES[8215](IS_STRUCTURE,0) = 1.000000; -NODES[8229](IS_STRUCTURE,0) = 1.000000; -NODES[8234](IS_STRUCTURE,0) = 1.000000; -NODES[8235](IS_STRUCTURE,0) = 1.000000; -NODES[8236](IS_STRUCTURE,0) = 1.000000; -NODES[8237](IS_STRUCTURE,0) = 1.000000; -NODES[8238](IS_STRUCTURE,0) = 1.000000; -NODES[8239](IS_STRUCTURE,0) = 1.000000; -NODES[8240](IS_STRUCTURE,0) = 1.000000; -NODES[8241](IS_STRUCTURE,0) = 1.000000; -NODES[8242](IS_STRUCTURE,0) = 1.000000; -NODES[8248](IS_STRUCTURE,0) = 1.000000; -NODES[8253](IS_STRUCTURE,0) = 1.000000; -NODES[8254](IS_STRUCTURE,0) = 1.000000; -NODES[8255](IS_STRUCTURE,0) = 1.000000; -NODES[8262](IS_STRUCTURE,0) = 1.000000; -NODES[8263](IS_STRUCTURE,0) = 1.000000; -NODES[8264](IS_STRUCTURE,0) = 1.000000; -NODES[8267](IS_STRUCTURE,0) = 1.000000; -NODES[8275](IS_STRUCTURE,0) = 1.000000; -NODES[8277](IS_STRUCTURE,0) = 1.000000; -NODES[8278](IS_STRUCTURE,0) = 1.000000; -NODES[8279](IS_STRUCTURE,0) = 1.000000; -NODES[8280](IS_STRUCTURE,0) = 1.000000; -NODES[8285](IS_STRUCTURE,0) = 1.000000; -NODES[8286](IS_STRUCTURE,0) = 1.000000; -NODES[8287](IS_STRUCTURE,0) = 1.000000; -NODES[8293](IS_STRUCTURE,0) = 1.000000; -NODES[8301](IS_STRUCTURE,0) = 1.000000; -NODES[8313](IS_STRUCTURE,0) = 1.000000; -NODES[8315](IS_STRUCTURE,0) = 1.000000; -NODES[8316](IS_STRUCTURE,0) = 1.000000; -NODES[8317](IS_STRUCTURE,0) = 1.000000; -NODES[8319](IS_STRUCTURE,0) = 1.000000; -NODES[8320](IS_STRUCTURE,0) = 1.000000; -NODES[8328](IS_STRUCTURE,0) = 1.000000; -NODES[8352](IS_STRUCTURE,0) = 1.000000; -NODES[8356](IS_STRUCTURE,0) = 1.000000; -NODES[8357](IS_STRUCTURE,0) = 1.000000; -NODES[8363](IS_STRUCTURE,0) = 1.000000; -NODES[8371](IS_STRUCTURE,0) = 1.000000; -NODES[8377](IS_STRUCTURE,0) = 1.000000; -NODES[8390](IS_STRUCTURE,0) = 1.000000; -NODES[8391](IS_STRUCTURE,0) = 1.000000; -NODES[8392](IS_STRUCTURE,0) = 1.000000; -NODES[8393](IS_STRUCTURE,0) = 1.000000; -NODES[8394](IS_STRUCTURE,0) = 1.000000; -NODES[8400](IS_STRUCTURE,0) = 1.000000; -NODES[8401](IS_STRUCTURE,0) = 1.000000; -NODES[8403](IS_STRUCTURE,0) = 1.000000; -NODES[8407](IS_STRUCTURE,0) = 1.000000; -NODES[8408](IS_STRUCTURE,0) = 1.000000; -NODES[8419](IS_STRUCTURE,0) = 1.000000; -NODES[8420](IS_STRUCTURE,0) = 1.000000; -NODES[8421](IS_STRUCTURE,0) = 1.000000; -NODES[8422](IS_STRUCTURE,0) = 1.000000; -NODES[8434](IS_STRUCTURE,0) = 1.000000; -NODES[8435](IS_STRUCTURE,0) = 1.000000; -NODES[8436](IS_STRUCTURE,0) = 1.000000; -NODES[8443](IS_STRUCTURE,0) = 1.000000; -NODES[8445](IS_STRUCTURE,0) = 1.000000; -NODES[8454](IS_STRUCTURE,0) = 1.000000; -NODES[8456](IS_STRUCTURE,0) = 1.000000; -NODES[8472](IS_STRUCTURE,0) = 1.000000; -NODES[8476](IS_STRUCTURE,0) = 1.000000; -NODES[8480](IS_STRUCTURE,0) = 1.000000; -NODES[8481](IS_STRUCTURE,0) = 1.000000; -NODES[8482](IS_STRUCTURE,0) = 1.000000; -NODES[8490](IS_STRUCTURE,0) = 1.000000; -NODES[8504](IS_STRUCTURE,0) = 1.000000; -NODES[8508](IS_STRUCTURE,0) = 1.000000; -NODES[8513](IS_STRUCTURE,0) = 1.000000; -NODES[8516](IS_STRUCTURE,0) = 1.000000; -NODES[8521](IS_STRUCTURE,0) = 1.000000; -NODES[8526](IS_STRUCTURE,0) = 1.000000; -NODES[8527](IS_STRUCTURE,0) = 1.000000; -NODES[8528](IS_STRUCTURE,0) = 1.000000; -NODES[8539](IS_STRUCTURE,0) = 1.000000; -NODES[8544](IS_STRUCTURE,0) = 1.000000; -NODES[8553](IS_STRUCTURE,0) = 1.000000; -NODES[8554](IS_STRUCTURE,0) = 1.000000; -NODES[8555](IS_STRUCTURE,0) = 1.000000; -NODES[8557](IS_STRUCTURE,0) = 1.000000; -NODES[8558](IS_STRUCTURE,0) = 1.000000; -NODES[8559](IS_STRUCTURE,0) = 1.000000; -NODES[8560](IS_STRUCTURE,0) = 1.000000; -NODES[8561](IS_STRUCTURE,0) = 1.000000; -NODES[8562](IS_STRUCTURE,0) = 1.000000; -NODES[8563](IS_STRUCTURE,0) = 1.000000; -NODES[8564](IS_STRUCTURE,0) = 1.000000; -NODES[8565](IS_STRUCTURE,0) = 1.000000; -NODES[8571](IS_STRUCTURE,0) = 1.000000; -NODES[8572](IS_STRUCTURE,0) = 1.000000; -NODES[8577](IS_STRUCTURE,0) = 1.000000; -NODES[8579](IS_STRUCTURE,0) = 1.000000; -NODES[8583](IS_STRUCTURE,0) = 1.000000; -NODES[8600](IS_STRUCTURE,0) = 1.000000; -NODES[8601](IS_STRUCTURE,0) = 1.000000; -NODES[8602](IS_STRUCTURE,0) = 1.000000; -NODES[8609](IS_STRUCTURE,0) = 1.000000; -NODES[8611](IS_STRUCTURE,0) = 1.000000; -NODES[8617](IS_STRUCTURE,0) = 1.000000; -NODES[8624](IS_STRUCTURE,0) = 1.000000; -NODES[8625](IS_STRUCTURE,0) = 1.000000; -NODES[8626](IS_STRUCTURE,0) = 1.000000; -NODES[8630](IS_STRUCTURE,0) = 1.000000; -NODES[8632](IS_STRUCTURE,0) = 1.000000; -NODES[8637](IS_STRUCTURE,0) = 1.000000; -NODES[8652](IS_STRUCTURE,0) = 1.000000; -NODES[8662](IS_STRUCTURE,0) = 1.000000; -NODES[8679](IS_STRUCTURE,0) = 1.000000; -NODES[8681](IS_STRUCTURE,0) = 1.000000; -NODES[8690](IS_STRUCTURE,0) = 1.000000; -NODES[8697](IS_STRUCTURE,0) = 1.000000; -NODES[8700](IS_STRUCTURE,0) = 1.000000; -NODES[8701](IS_STRUCTURE,0) = 1.000000; -NODES[8703](IS_STRUCTURE,0) = 1.000000; -NODES[8705](IS_STRUCTURE,0) = 1.000000; -NODES[8713](IS_STRUCTURE,0) = 1.000000; -NODES[8715](IS_STRUCTURE,0) = 1.000000; -NODES[8716](IS_STRUCTURE,0) = 1.000000; -NODES[8717](IS_STRUCTURE,0) = 1.000000; -NODES[8719](IS_STRUCTURE,0) = 1.000000; -NODES[8724](IS_STRUCTURE,0) = 1.000000; -NODES[8725](IS_STRUCTURE,0) = 1.000000; -NODES[8730](IS_STRUCTURE,0) = 1.000000; -NODES[8732](IS_STRUCTURE,0) = 1.000000; -NODES[8733](IS_STRUCTURE,0) = 1.000000; -NODES[8738](IS_STRUCTURE,0) = 1.000000; -NODES[8744](IS_STRUCTURE,0) = 1.000000; -NODES[8760](IS_STRUCTURE,0) = 1.000000; -NODES[8761](IS_STRUCTURE,0) = 1.000000; -NODES[8762](IS_STRUCTURE,0) = 1.000000; -NODES[8780](IS_STRUCTURE,0) = 1.000000; -NODES[8782](IS_STRUCTURE,0) = 1.000000; -NODES[8787](IS_STRUCTURE,0) = 1.000000; -NODES[8802](IS_STRUCTURE,0) = 1.000000; -NODES[8812](IS_STRUCTURE,0) = 1.000000; -NODES[8824](IS_STRUCTURE,0) = 1.000000; -NODES[8825](IS_STRUCTURE,0) = 1.000000; -NODES[8826](IS_STRUCTURE,0) = 1.000000; -NODES[8827](IS_STRUCTURE,0) = 1.000000; -NODES[8828](IS_STRUCTURE,0) = 1.000000; -NODES[8836](IS_STRUCTURE,0) = 1.000000; -NODES[8853](IS_STRUCTURE,0) = 1.000000; -NODES[8856](IS_STRUCTURE,0) = 1.000000; -NODES[8857](IS_STRUCTURE,0) = 1.000000; -NODES[8862](IS_STRUCTURE,0) = 1.000000; -NODES[8868](IS_STRUCTURE,0) = 1.000000; -NODES[8870](IS_STRUCTURE,0) = 1.000000; -NODES[8872](IS_STRUCTURE,0) = 1.000000; -NODES[8873](IS_STRUCTURE,0) = 1.000000; -NODES[8879](IS_STRUCTURE,0) = 1.000000; -NODES[8887](IS_STRUCTURE,0) = 1.000000; -NODES[8888](IS_STRUCTURE,0) = 1.000000; -NODES[8892](IS_STRUCTURE,0) = 1.000000; -NODES[8893](IS_STRUCTURE,0) = 1.000000; -NODES[8894](IS_STRUCTURE,0) = 1.000000; -NODES[8896](IS_STRUCTURE,0) = 1.000000; -NODES[8899](IS_STRUCTURE,0) = 1.000000; -NODES[8900](IS_STRUCTURE,0) = 1.000000; -NODES[8901](IS_STRUCTURE,0) = 1.000000; -NODES[8904](IS_STRUCTURE,0) = 1.000000; -NODES[8921](IS_STRUCTURE,0) = 1.000000; -NODES[8922](IS_STRUCTURE,0) = 1.000000; -NODES[8924](IS_STRUCTURE,0) = 1.000000; -NODES[8930](IS_STRUCTURE,0) = 1.000000; -NODES[8931](IS_STRUCTURE,0) = 1.000000; -NODES[8932](IS_STRUCTURE,0) = 1.000000; -NODES[8937](IS_STRUCTURE,0) = 1.000000; -NODES[8938](IS_STRUCTURE,0) = 1.000000; -NODES[8939](IS_STRUCTURE,0) = 1.000000; -NODES[8940](IS_STRUCTURE,0) = 1.000000; -NODES[8941](IS_STRUCTURE,0) = 1.000000; -NODES[8942](IS_STRUCTURE,0) = 1.000000; -NODES[8943](IS_STRUCTURE,0) = 1.000000; -NODES[8944](IS_STRUCTURE,0) = 1.000000; -NODES[8953](IS_STRUCTURE,0) = 1.000000; -NODES[8967](IS_STRUCTURE,0) = 1.000000; -NODES[8972](IS_STRUCTURE,0) = 1.000000; -NODES[8973](IS_STRUCTURE,0) = 1.000000; -NODES[8974](IS_STRUCTURE,0) = 1.000000; -NODES[8975](IS_STRUCTURE,0) = 1.000000; -NODES[8980](IS_STRUCTURE,0) = 1.000000; -NODES[8983](IS_STRUCTURE,0) = 1.000000; -NODES[8984](IS_STRUCTURE,0) = 1.000000; -NODES[8985](IS_STRUCTURE,0) = 1.000000; -NODES[8986](IS_STRUCTURE,0) = 1.000000; -NODES[8992](IS_STRUCTURE,0) = 1.000000; -NODES[8993](IS_STRUCTURE,0) = 1.000000; -NODES[9006](IS_STRUCTURE,0) = 1.000000; -NODES[9007](IS_STRUCTURE,0) = 1.000000; -NODES[9010](IS_STRUCTURE,0) = 1.000000; -NODES[9018](IS_STRUCTURE,0) = 1.000000; -NODES[9023](IS_STRUCTURE,0) = 1.000000; -NODES[9025](IS_STRUCTURE,0) = 1.000000; -NODES[9026](IS_STRUCTURE,0) = 1.000000; -NODES[9031](IS_STRUCTURE,0) = 1.000000; -NODES[9048](IS_STRUCTURE,0) = 1.000000; -NODES[9049](IS_STRUCTURE,0) = 1.000000; -NODES[9056](IS_STRUCTURE,0) = 1.000000; -NODES[9059](IS_STRUCTURE,0) = 1.000000; -NODES[9060](IS_STRUCTURE,0) = 1.000000; -NODES[9066](IS_STRUCTURE,0) = 1.000000; -NODES[9071](IS_STRUCTURE,0) = 1.000000; -NODES[9076](IS_STRUCTURE,0) = 1.000000; -NODES[9077](IS_STRUCTURE,0) = 1.000000; -NODES[9078](IS_STRUCTURE,0) = 1.000000; -NODES[9092](IS_STRUCTURE,0) = 1.000000; -NODES[9100](IS_STRUCTURE,0) = 1.000000; -NODES[9101](IS_STRUCTURE,0) = 1.000000; -NODES[9122](IS_STRUCTURE,0) = 1.000000; -NODES[9123](IS_STRUCTURE,0) = 1.000000; -NODES[9124](IS_STRUCTURE,0) = 1.000000; -NODES[9125](IS_STRUCTURE,0) = 1.000000; -NODES[9134](IS_STRUCTURE,0) = 1.000000; -NODES[9136](IS_STRUCTURE,0) = 1.000000; -NODES[9137](IS_STRUCTURE,0) = 1.000000; -NODES[9147](IS_STRUCTURE,0) = 1.000000; -NODES[9154](IS_STRUCTURE,0) = 1.000000; -NODES[9155](IS_STRUCTURE,0) = 1.000000; -NODES[9158](IS_STRUCTURE,0) = 1.000000; -NODES[9159](IS_STRUCTURE,0) = 1.000000; -NODES[9162](IS_STRUCTURE,0) = 1.000000; -NODES[9163](IS_STRUCTURE,0) = 1.000000; -NODES[9166](IS_STRUCTURE,0) = 1.000000; -NODES[9167](IS_STRUCTURE,0) = 1.000000; -NODES[9168](IS_STRUCTURE,0) = 1.000000; -NODES[9172](IS_STRUCTURE,0) = 1.000000; -NODES[9188](IS_STRUCTURE,0) = 1.000000; -NODES[9193](IS_STRUCTURE,0) = 1.000000; -NODES[9194](IS_STRUCTURE,0) = 1.000000; -NODES[9195](IS_STRUCTURE,0) = 1.000000; -NODES[9196](IS_STRUCTURE,0) = 1.000000; -NODES[9197](IS_STRUCTURE,0) = 1.000000; -NODES[9198](IS_STRUCTURE,0) = 1.000000; -NODES[9199](IS_STRUCTURE,0) = 1.000000; -NODES[9218](IS_STRUCTURE,0) = 1.000000; -NODES[9222](IS_STRUCTURE,0) = 1.000000; -NODES[9232](IS_STRUCTURE,0) = 1.000000; -NODES[9233](IS_STRUCTURE,0) = 1.000000; -NODES[9245](IS_STRUCTURE,0) = 1.000000; -NODES[9248](IS_STRUCTURE,0) = 1.000000; -NODES[9249](IS_STRUCTURE,0) = 1.000000; -NODES[9250](IS_STRUCTURE,0) = 1.000000; -NODES[9251](IS_STRUCTURE,0) = 1.000000; -NODES[9254](IS_STRUCTURE,0) = 1.000000; -NODES[9256](IS_STRUCTURE,0) = 1.000000; -NODES[9272](IS_STRUCTURE,0) = 1.000000; -NODES[9273](IS_STRUCTURE,0) = 1.000000; -NODES[9275](IS_STRUCTURE,0) = 1.000000; -NODES[9277](IS_STRUCTURE,0) = 1.000000; -NODES[9278](IS_STRUCTURE,0) = 1.000000; -NODES[9282](IS_STRUCTURE,0) = 1.000000; -NODES[9283](IS_STRUCTURE,0) = 1.000000; -NODES[9291](IS_STRUCTURE,0) = 1.000000; -NODES[9292](IS_STRUCTURE,0) = 1.000000; -NODES[9300](IS_STRUCTURE,0) = 1.000000; -NODES[9301](IS_STRUCTURE,0) = 1.000000; -NODES[9302](IS_STRUCTURE,0) = 1.000000; -NODES[9303](IS_STRUCTURE,0) = 1.000000; -NODES[9304](IS_STRUCTURE,0) = 1.000000; -NODES[9305](IS_STRUCTURE,0) = 1.000000; -NODES[9315](IS_STRUCTURE,0) = 1.000000; -NODES[9318](IS_STRUCTURE,0) = 1.000000; -NODES[9324](IS_STRUCTURE,0) = 1.000000; -NODES[9326](IS_STRUCTURE,0) = 1.000000; -NODES[9332](IS_STRUCTURE,0) = 1.000000; -NODES[9339](IS_STRUCTURE,0) = 1.000000; -NODES[9342](IS_STRUCTURE,0) = 1.000000; -NODES[9343](IS_STRUCTURE,0) = 1.000000; -NODES[9344](IS_STRUCTURE,0) = 1.000000; -NODES[9345](IS_STRUCTURE,0) = 1.000000; -NODES[9346](IS_STRUCTURE,0) = 1.000000; -NODES[9347](IS_STRUCTURE,0) = 1.000000; -NODES[9349](IS_STRUCTURE,0) = 1.000000; -NODES[9369](IS_STRUCTURE,0) = 1.000000; -NODES[9370](IS_STRUCTURE,0) = 1.000000; -NODES[9380](IS_STRUCTURE,0) = 1.000000; -NODES[9388](IS_STRUCTURE,0) = 1.000000; -NODES[9394](IS_STRUCTURE,0) = 1.000000; -NODES[9405](IS_STRUCTURE,0) = 1.000000; -NODES[9422](IS_STRUCTURE,0) = 1.000000; -NODES[9423](IS_STRUCTURE,0) = 1.000000; -NODES[9425](IS_STRUCTURE,0) = 1.000000; -NODES[9432](IS_STRUCTURE,0) = 1.000000; -NODES[9435](IS_STRUCTURE,0) = 1.000000; -NODES[9436](IS_STRUCTURE,0) = 1.000000; -NODES[9449](IS_STRUCTURE,0) = 1.000000; -NODES[9450](IS_STRUCTURE,0) = 1.000000; -NODES[9453](IS_STRUCTURE,0) = 1.000000; -NODES[9454](IS_STRUCTURE,0) = 1.000000; -NODES[9490](IS_STRUCTURE,0) = 1.000000; -NODES[9494](IS_STRUCTURE,0) = 1.000000; -NODES[9496](IS_STRUCTURE,0) = 1.000000; -NODES[9497](IS_STRUCTURE,0) = 1.000000; -NODES[9507](IS_STRUCTURE,0) = 1.000000; -NODES[9515](IS_STRUCTURE,0) = 1.000000; -NODES[9521](IS_STRUCTURE,0) = 1.000000; -NODES[9522](IS_STRUCTURE,0) = 1.000000; -NODES[9523](IS_STRUCTURE,0) = 1.000000; -NODES[9524](IS_STRUCTURE,0) = 1.000000; -NODES[9525](IS_STRUCTURE,0) = 1.000000; -NODES[9526](IS_STRUCTURE,0) = 1.000000; -NODES[9537](IS_STRUCTURE,0) = 1.000000; -NODES[9539](IS_STRUCTURE,0) = 1.000000; -NODES[9541](IS_STRUCTURE,0) = 1.000000; -NODES[9547](IS_STRUCTURE,0) = 1.000000; -NODES[9557](IS_STRUCTURE,0) = 1.000000; -NODES[9558](IS_STRUCTURE,0) = 1.000000; -NODES[9561](IS_STRUCTURE,0) = 1.000000; -NODES[9562](IS_STRUCTURE,0) = 1.000000; -NODES[9563](IS_STRUCTURE,0) = 1.000000; -NODES[9578](IS_STRUCTURE,0) = 1.000000; -NODES[9579](IS_STRUCTURE,0) = 1.000000; -NODES[9580](IS_STRUCTURE,0) = 1.000000; -NODES[9586](IS_STRUCTURE,0) = 1.000000; -NODES[9600](IS_STRUCTURE,0) = 1.000000; -NODES[9605](IS_STRUCTURE,0) = 1.000000; -NODES[9606](IS_STRUCTURE,0) = 1.000000; -NODES[9624](IS_STRUCTURE,0) = 1.000000; -NODES[9625](IS_STRUCTURE,0) = 1.000000; -NODES[9626](IS_STRUCTURE,0) = 1.000000; -NODES[9632](IS_STRUCTURE,0) = 1.000000; -NODES[9639](IS_STRUCTURE,0) = 1.000000; -NODES[9643](IS_STRUCTURE,0) = 1.000000; -NODES[9650](IS_STRUCTURE,0) = 1.000000; -NODES[9651](IS_STRUCTURE,0) = 1.000000; -NODES[9654](IS_STRUCTURE,0) = 1.000000; -NODES[9656](IS_STRUCTURE,0) = 1.000000; -NODES[9670](IS_STRUCTURE,0) = 1.000000; -NODES[9671](IS_STRUCTURE,0) = 1.000000; -NODES[9694](IS_STRUCTURE,0) = 1.000000; -NODES[9700](IS_STRUCTURE,0) = 1.000000; -NODES[9711](IS_STRUCTURE,0) = 1.000000; -NODES[9716](IS_STRUCTURE,0) = 1.000000; -NODES[9718](IS_STRUCTURE,0) = 1.000000; -NODES[9719](IS_STRUCTURE,0) = 1.000000; -NODES[9721](IS_STRUCTURE,0) = 1.000000; -NODES[9726](IS_STRUCTURE,0) = 1.000000; -NODES[9727](IS_STRUCTURE,0) = 1.000000; -NODES[9728](IS_STRUCTURE,0) = 1.000000; -NODES[9729](IS_STRUCTURE,0) = 1.000000; -NODES[9730](IS_STRUCTURE,0) = 1.000000; -NODES[9731](IS_STRUCTURE,0) = 1.000000; -NODES[9732](IS_STRUCTURE,0) = 1.000000; -NODES[9736](IS_STRUCTURE,0) = 1.000000; -NODES[9737](IS_STRUCTURE,0) = 1.000000; -NODES[9739](IS_STRUCTURE,0) = 1.000000; -NODES[9740](IS_STRUCTURE,0) = 1.000000; -NODES[9742](IS_STRUCTURE,0) = 1.000000; -NODES[9743](IS_STRUCTURE,0) = 1.000000; -NODES[9746](IS_STRUCTURE,0) = 1.000000; -NODES[9749](IS_STRUCTURE,0) = 1.000000; -NODES[9750](IS_STRUCTURE,0) = 1.000000; -NODES[9757](IS_STRUCTURE,0) = 1.000000; -NODES[9759](IS_STRUCTURE,0) = 1.000000; -NODES[9763](IS_STRUCTURE,0) = 1.000000; -NODES[9765](IS_STRUCTURE,0) = 1.000000; -NODES[9767](IS_STRUCTURE,0) = 1.000000; -NODES[9768](IS_STRUCTURE,0) = 1.000000; -NODES[9769](IS_STRUCTURE,0) = 1.000000; -NODES[9778](IS_STRUCTURE,0) = 1.000000; -NODES[9783](IS_STRUCTURE,0) = 1.000000; -NODES[9784](IS_STRUCTURE,0) = 1.000000; -NODES[9789](IS_STRUCTURE,0) = 1.000000; -NODES[9805](IS_STRUCTURE,0) = 1.000000; -NODES[9810](IS_STRUCTURE,0) = 1.000000; -NODES[9814](IS_STRUCTURE,0) = 1.000000; -NODES[9829](IS_STRUCTURE,0) = 1.000000; -NODES[9830](IS_STRUCTURE,0) = 1.000000; -NODES[9831](IS_STRUCTURE,0) = 1.000000; -NODES[9841](IS_STRUCTURE,0) = 1.000000; -NODES[9842](IS_STRUCTURE,0) = 1.000000; -NODES[9843](IS_STRUCTURE,0) = 1.000000; -NODES[9844](IS_STRUCTURE,0) = 1.000000; -NODES[9861](IS_STRUCTURE,0) = 1.000000; -NODES[9864](IS_STRUCTURE,0) = 1.000000; -NODES[9867](IS_STRUCTURE,0) = 1.000000; -NODES[9868](IS_STRUCTURE,0) = 1.000000; -NODES[9873](IS_STRUCTURE,0) = 1.000000; -NODES[9874](IS_STRUCTURE,0) = 1.000000; -NODES[9878](IS_STRUCTURE,0) = 1.000000; -NODES[9879](IS_STRUCTURE,0) = 1.000000; -NODES[9880](IS_STRUCTURE,0) = 1.000000; -NODES[9881](IS_STRUCTURE,0) = 1.000000; -NODES[9891](IS_STRUCTURE,0) = 1.000000; -NODES[9897](IS_STRUCTURE,0) = 1.000000; -NODES[9900](IS_STRUCTURE,0) = 1.000000; -NODES[9915](IS_STRUCTURE,0) = 1.000000; -NODES[9916](IS_STRUCTURE,0) = 1.000000; -NODES[9921](IS_STRUCTURE,0) = 1.000000; -NODES[9926](IS_STRUCTURE,0) = 1.000000; -NODES[9930](IS_STRUCTURE,0) = 1.000000; -NODES[9937](IS_STRUCTURE,0) = 1.000000; -NODES[9938](IS_STRUCTURE,0) = 1.000000; -NODES[9939](IS_STRUCTURE,0) = 1.000000; -NODES[9946](IS_STRUCTURE,0) = 1.000000; -NODES[9947](IS_STRUCTURE,0) = 1.000000; -NODES[9948](IS_STRUCTURE,0) = 1.000000; -NODES[9964](IS_STRUCTURE,0) = 1.000000; -NODES[9975](IS_STRUCTURE,0) = 1.000000; -NODES[9976](IS_STRUCTURE,0) = 1.000000; -NODES[9978](IS_STRUCTURE,0) = 1.000000; -NODES[9979](IS_STRUCTURE,0) = 1.000000; -NODES[9981](IS_STRUCTURE,0) = 1.000000; -NODES[9987](IS_STRUCTURE,0) = 1.000000; -NODES[9988](IS_STRUCTURE,0) = 1.000000; -NODES[9989](IS_STRUCTURE,0) = 1.000000; -NODES[10011](IS_STRUCTURE,0) = 1.000000; -NODES[10024](IS_STRUCTURE,0) = 1.000000; -NODES[10025](IS_STRUCTURE,0) = 1.000000; -NODES[10032](IS_STRUCTURE,0) = 1.000000; -NODES[10039](IS_STRUCTURE,0) = 1.000000; -NODES[10045](IS_STRUCTURE,0) = 1.000000; -NODES[10046](IS_STRUCTURE,0) = 1.000000; -NODES[10047](IS_STRUCTURE,0) = 1.000000; -NODES[10052](IS_STRUCTURE,0) = 1.000000; -NODES[10053](IS_STRUCTURE,0) = 1.000000; -NODES[10060](IS_STRUCTURE,0) = 1.000000; -NODES[10062](IS_STRUCTURE,0) = 1.000000; -NODES[10063](IS_STRUCTURE,0) = 1.000000; -NODES[10064](IS_STRUCTURE,0) = 1.000000; -NODES[10067](IS_STRUCTURE,0) = 1.000000; -NODES[10075](IS_STRUCTURE,0) = 1.000000; -NODES[10081](IS_STRUCTURE,0) = 1.000000; -NODES[10083](IS_STRUCTURE,0) = 1.000000; -NODES[10095](IS_STRUCTURE,0) = 1.000000; -NODES[10101](IS_STRUCTURE,0) = 1.000000; -NODES[10111](IS_STRUCTURE,0) = 1.000000; -NODES[10124](IS_STRUCTURE,0) = 1.000000; -NODES[10125](IS_STRUCTURE,0) = 1.000000; -NODES[10129](IS_STRUCTURE,0) = 1.000000; -NODES[10136](IS_STRUCTURE,0) = 1.000000; -NODES[10139](IS_STRUCTURE,0) = 1.000000; -NODES[10140](IS_STRUCTURE,0) = 1.000000; -NODES[10141](IS_STRUCTURE,0) = 1.000000; -NODES[10150](IS_STRUCTURE,0) = 1.000000; -NODES[10151](IS_STRUCTURE,0) = 1.000000; -NODES[10161](IS_STRUCTURE,0) = 1.000000; -NODES[10162](IS_STRUCTURE,0) = 1.000000; -NODES[10163](IS_STRUCTURE,0) = 1.000000; -NODES[10164](IS_STRUCTURE,0) = 1.000000; -NODES[10165](IS_STRUCTURE,0) = 1.000000; -NODES[10166](IS_STRUCTURE,0) = 1.000000; -NODES[10172](IS_STRUCTURE,0) = 1.000000; -NODES[10175](IS_STRUCTURE,0) = 1.000000; -NODES[10176](IS_STRUCTURE,0) = 1.000000; -NODES[10177](IS_STRUCTURE,0) = 1.000000; -NODES[10183](IS_STRUCTURE,0) = 1.000000; -NODES[10189](IS_STRUCTURE,0) = 1.000000; -NODES[10196](IS_STRUCTURE,0) = 1.000000; -NODES[10197](IS_STRUCTURE,0) = 1.000000; -NODES[10198](IS_STRUCTURE,0) = 1.000000; -NODES[10201](IS_STRUCTURE,0) = 1.000000; -NODES[10203](IS_STRUCTURE,0) = 1.000000; -NODES[10204](IS_STRUCTURE,0) = 1.000000; -NODES[10223](IS_STRUCTURE,0) = 1.000000; -NODES[10226](IS_STRUCTURE,0) = 1.000000; -NODES[10227](IS_STRUCTURE,0) = 1.000000; -NODES[10237](IS_STRUCTURE,0) = 1.000000; -NODES[10246](IS_STRUCTURE,0) = 1.000000; -NODES[10247](IS_STRUCTURE,0) = 1.000000; -NODES[10251](IS_STRUCTURE,0) = 1.000000; -NODES[10253](IS_STRUCTURE,0) = 1.000000; -NODES[10259](IS_STRUCTURE,0) = 1.000000; -NODES[10279](IS_STRUCTURE,0) = 1.000000; -NODES[10280](IS_STRUCTURE,0) = 1.000000; -NODES[10285](IS_STRUCTURE,0) = 1.000000; -NODES[10286](IS_STRUCTURE,0) = 1.000000; -NODES[10300](IS_STRUCTURE,0) = 1.000000; -NODES[10301](IS_STRUCTURE,0) = 1.000000; -NODES[10311](IS_STRUCTURE,0) = 1.000000; -NODES[10312](IS_STRUCTURE,0) = 1.000000; -NODES[10315](IS_STRUCTURE,0) = 1.000000; -NODES[10328](IS_STRUCTURE,0) = 1.000000; -NODES[10331](IS_STRUCTURE,0) = 1.000000; -NODES[10332](IS_STRUCTURE,0) = 1.000000; -NODES[10334](IS_STRUCTURE,0) = 1.000000; -NODES[10341](IS_STRUCTURE,0) = 1.000000; -NODES[10342](IS_STRUCTURE,0) = 1.000000; -NODES[10348](IS_STRUCTURE,0) = 1.000000; -NODES[10353](IS_STRUCTURE,0) = 1.000000; -NODES[10355](IS_STRUCTURE,0) = 1.000000; -NODES[10375](IS_STRUCTURE,0) = 1.000000; -NODES[10379](IS_STRUCTURE,0) = 1.000000; -NODES[10380](IS_STRUCTURE,0) = 1.000000; -NODES[10385](IS_STRUCTURE,0) = 1.000000; -NODES[10395](IS_STRUCTURE,0) = 1.000000; -NODES[10411](IS_STRUCTURE,0) = 1.000000; -NODES[10412](IS_STRUCTURE,0) = 1.000000; -NODES[10415](IS_STRUCTURE,0) = 1.000000; -NODES[10416](IS_STRUCTURE,0) = 1.000000; -NODES[10417](IS_STRUCTURE,0) = 1.000000; -NODES[10418](IS_STRUCTURE,0) = 1.000000; -NODES[10423](IS_STRUCTURE,0) = 1.000000; -NODES[10444](IS_STRUCTURE,0) = 1.000000; -NODES[10445](IS_STRUCTURE,0) = 1.000000; -NODES[10460](IS_STRUCTURE,0) = 1.000000; -NODES[10481](IS_STRUCTURE,0) = 1.000000; -NODES[10485](IS_STRUCTURE,0) = 1.000000; -NODES[10489](IS_STRUCTURE,0) = 1.000000; -NODES[10490](IS_STRUCTURE,0) = 1.000000; -NODES[10491](IS_STRUCTURE,0) = 1.000000; -NODES[10499](IS_STRUCTURE,0) = 1.000000; -NODES[10505](IS_STRUCTURE,0) = 1.000000; -NODES[10507](IS_STRUCTURE,0) = 1.000000; -NODES[10508](IS_STRUCTURE,0) = 1.000000; -NODES[10510](IS_STRUCTURE,0) = 1.000000; -NODES[10513](IS_STRUCTURE,0) = 1.000000; -NODES[10517](IS_STRUCTURE,0) = 1.000000; -NODES[10518](IS_STRUCTURE,0) = 1.000000; -NODES[10519](IS_STRUCTURE,0) = 1.000000; -NODES[10521](IS_STRUCTURE,0) = 1.000000; -NODES[10522](IS_STRUCTURE,0) = 1.000000; -NODES[10523](IS_STRUCTURE,0) = 1.000000; -NODES[10532](IS_STRUCTURE,0) = 1.000000; -NODES[10547](IS_STRUCTURE,0) = 1.000000; -NODES[10554](IS_STRUCTURE,0) = 1.000000; -NODES[10565](IS_STRUCTURE,0) = 1.000000; -NODES[10574](IS_STRUCTURE,0) = 1.000000; -NODES[10578](IS_STRUCTURE,0) = 1.000000; -NODES[10583](IS_STRUCTURE,0) = 1.000000; -NODES[10584](IS_STRUCTURE,0) = 1.000000; -NODES[10585](IS_STRUCTURE,0) = 1.000000; -NODES[10588](IS_STRUCTURE,0) = 1.000000; -NODES[10589](IS_STRUCTURE,0) = 1.000000; -NODES[10598](IS_STRUCTURE,0) = 1.000000; -NODES[10607](IS_STRUCTURE,0) = 1.000000; -NODES[10608](IS_STRUCTURE,0) = 1.000000; -NODES[10609](IS_STRUCTURE,0) = 1.000000; -NODES[10610](IS_STRUCTURE,0) = 1.000000; -NODES[10611](IS_STRUCTURE,0) = 1.000000; -NODES[10616](IS_STRUCTURE,0) = 1.000000; -NODES[10617](IS_STRUCTURE,0) = 1.000000; -NODES[10620](IS_STRUCTURE,0) = 1.000000; -NODES[10643](IS_STRUCTURE,0) = 1.000000; -NODES[10644](IS_STRUCTURE,0) = 1.000000; -NODES[10645](IS_STRUCTURE,0) = 1.000000; -NODES[10646](IS_STRUCTURE,0) = 1.000000; -NODES[10647](IS_STRUCTURE,0) = 1.000000; -NODES[10648](IS_STRUCTURE,0) = 1.000000; -NODES[10649](IS_STRUCTURE,0) = 1.000000; -NODES[10650](IS_STRUCTURE,0) = 1.000000; -NODES[10654](IS_STRUCTURE,0) = 1.000000; -NODES[10663](IS_STRUCTURE,0) = 1.000000; -NODES[10665](IS_STRUCTURE,0) = 1.000000; -NODES[10667](IS_STRUCTURE,0) = 1.000000; -NODES[10682](IS_STRUCTURE,0) = 1.000000; -NODES[10683](IS_STRUCTURE,0) = 1.000000; -NODES[10684](IS_STRUCTURE,0) = 1.000000; -NODES[10685](IS_STRUCTURE,0) = 1.000000; -NODES[10687](IS_STRUCTURE,0) = 1.000000; -NODES[10691](IS_STRUCTURE,0) = 1.000000; -NODES[10692](IS_STRUCTURE,0) = 1.000000; -NODES[10693](IS_STRUCTURE,0) = 1.000000; -NODES[10694](IS_STRUCTURE,0) = 1.000000; -NODES[10710](IS_STRUCTURE,0) = 1.000000; -NODES[10715](IS_STRUCTURE,0) = 1.000000; -NODES[10721](IS_STRUCTURE,0) = 1.000000; -NODES[10731](IS_STRUCTURE,0) = 1.000000; -NODES[10732](IS_STRUCTURE,0) = 1.000000; -NODES[10733](IS_STRUCTURE,0) = 1.000000; -NODES[10734](IS_STRUCTURE,0) = 1.000000; -NODES[10735](IS_STRUCTURE,0) = 1.000000; -NODES[10736](IS_STRUCTURE,0) = 1.000000; -NODES[10748](IS_STRUCTURE,0) = 1.000000; -NODES[10751](IS_STRUCTURE,0) = 1.000000; -NODES[10758](IS_STRUCTURE,0) = 1.000000; -NODES[10759](IS_STRUCTURE,0) = 1.000000; -NODES[10762](IS_STRUCTURE,0) = 1.000000; -NODES[10763](IS_STRUCTURE,0) = 1.000000; -NODES[10787](IS_STRUCTURE,0) = 1.000000; -NODES[10792](IS_STRUCTURE,0) = 1.000000; -NODES[10793](IS_STRUCTURE,0) = 1.000000; -NODES[10798](IS_STRUCTURE,0) = 1.000000; -NODES[10799](IS_STRUCTURE,0) = 1.000000; -NODES[10802](IS_STRUCTURE,0) = 1.000000; -NODES[10804](IS_STRUCTURE,0) = 1.000000; -NODES[10808](IS_STRUCTURE,0) = 1.000000; -NODES[10816](IS_STRUCTURE,0) = 1.000000; -NODES[10827](IS_STRUCTURE,0) = 1.000000; -NODES[10828](IS_STRUCTURE,0) = 1.000000; -NODES[10832](IS_STRUCTURE,0) = 1.000000; -NODES[10836](IS_STRUCTURE,0) = 1.000000; -NODES[10842](IS_STRUCTURE,0) = 1.000000; -NODES[10843](IS_STRUCTURE,0) = 1.000000; -NODES[10863](IS_STRUCTURE,0) = 1.000000; -NODES[10871](IS_STRUCTURE,0) = 1.000000; -NODES[10877](IS_STRUCTURE,0) = 1.000000; -NODES[10878](IS_STRUCTURE,0) = 1.000000; -NODES[10879](IS_STRUCTURE,0) = 1.000000; -NODES[10884](IS_STRUCTURE,0) = 1.000000; -NODES[10885](IS_STRUCTURE,0) = 1.000000; -NODES[10892](IS_STRUCTURE,0) = 1.000000; -NODES[10913](IS_STRUCTURE,0) = 1.000000; -NODES[10917](IS_STRUCTURE,0) = 1.000000; -NODES[10929](IS_STRUCTURE,0) = 1.000000; -NODES[10934](IS_STRUCTURE,0) = 1.000000; -NODES[10935](IS_STRUCTURE,0) = 1.000000; -NODES[10936](IS_STRUCTURE,0) = 1.000000; -NODES[10938](IS_STRUCTURE,0) = 1.000000; -NODES[10944](IS_STRUCTURE,0) = 1.000000; -NODES[10947](IS_STRUCTURE,0) = 1.000000; -NODES[10950](IS_STRUCTURE,0) = 1.000000; -NODES[10952](IS_STRUCTURE,0) = 1.000000; -NODES[10963](IS_STRUCTURE,0) = 1.000000; -NODES[10971](IS_STRUCTURE,0) = 1.000000; -NODES[10972](IS_STRUCTURE,0) = 1.000000; -NODES[10979](IS_STRUCTURE,0) = 1.000000; -NODES[10980](IS_STRUCTURE,0) = 1.000000; -NODES[10991](IS_STRUCTURE,0) = 1.000000; -NODES[10992](IS_STRUCTURE,0) = 1.000000; -NODES[10995](IS_STRUCTURE,0) = 1.000000; -NODES[10996](IS_STRUCTURE,0) = 1.000000; -NODES[10997](IS_STRUCTURE,0) = 1.000000; -NODES[11015](IS_STRUCTURE,0) = 1.000000; -NODES[11017](IS_STRUCTURE,0) = 1.000000; -NODES[11036](IS_STRUCTURE,0) = 1.000000; -NODES[11047](IS_STRUCTURE,0) = 1.000000; -NODES[11065](IS_STRUCTURE,0) = 1.000000; -NODES[11075](IS_STRUCTURE,0) = 1.000000; -NODES[11078](IS_STRUCTURE,0) = 1.000000; -NODES[11090](IS_STRUCTURE,0) = 1.000000; -NODES[11092](IS_STRUCTURE,0) = 1.000000; -NODES[11093](IS_STRUCTURE,0) = 1.000000; -NODES[11100](IS_STRUCTURE,0) = 1.000000; -NODES[11101](IS_STRUCTURE,0) = 1.000000; -NODES[11106](IS_STRUCTURE,0) = 1.000000; -NODES[11107](IS_STRUCTURE,0) = 1.000000; -NODES[11112](IS_STRUCTURE,0) = 1.000000; -NODES[11113](IS_STRUCTURE,0) = 1.000000; -NODES[11125](IS_STRUCTURE,0) = 1.000000; -NODES[11126](IS_STRUCTURE,0) = 1.000000; -NODES[11127](IS_STRUCTURE,0) = 1.000000; -NODES[11137](IS_STRUCTURE,0) = 1.000000; -NODES[11139](IS_STRUCTURE,0) = 1.000000; -NODES[11140](IS_STRUCTURE,0) = 1.000000; -NODES[11141](IS_STRUCTURE,0) = 1.000000; -NODES[11142](IS_STRUCTURE,0) = 1.000000; -NODES[11143](IS_STRUCTURE,0) = 1.000000; -NODES[11151](IS_STRUCTURE,0) = 1.000000; -NODES[11154](IS_STRUCTURE,0) = 1.000000; -NODES[11155](IS_STRUCTURE,0) = 1.000000; -NODES[11156](IS_STRUCTURE,0) = 1.000000; -NODES[11157](IS_STRUCTURE,0) = 1.000000; -NODES[11165](IS_STRUCTURE,0) = 1.000000; -NODES[11176](IS_STRUCTURE,0) = 1.000000; -NODES[11179](IS_STRUCTURE,0) = 1.000000; -NODES[11180](IS_STRUCTURE,0) = 1.000000; -NODES[11192](IS_STRUCTURE,0) = 1.000000; -NODES[11193](IS_STRUCTURE,0) = 1.000000; -NODES[11194](IS_STRUCTURE,0) = 1.000000; -NODES[11195](IS_STRUCTURE,0) = 1.000000; -NODES[11202](IS_STRUCTURE,0) = 1.000000; -NODES[11213](IS_STRUCTURE,0) = 1.000000; -NODES[11227](IS_STRUCTURE,0) = 1.000000; -NODES[11247](IS_STRUCTURE,0) = 1.000000; -NODES[11250](IS_STRUCTURE,0) = 1.000000; -NODES[11251](IS_STRUCTURE,0) = 1.000000; -NODES[11252](IS_STRUCTURE,0) = 1.000000; -NODES[11262](IS_STRUCTURE,0) = 1.000000; -NODES[11263](IS_STRUCTURE,0) = 1.000000; -NODES[11264](IS_STRUCTURE,0) = 1.000000; -NODES[11265](IS_STRUCTURE,0) = 1.000000; -NODES[11266](IS_STRUCTURE,0) = 1.000000; -NODES[11270](IS_STRUCTURE,0) = 1.000000; -NODES[11302](IS_STRUCTURE,0) = 1.000000; -NODES[11309](IS_STRUCTURE,0) = 1.000000; -NODES[11319](IS_STRUCTURE,0) = 1.000000; -NODES[11329](IS_STRUCTURE,0) = 1.000000; -NODES[11334](IS_STRUCTURE,0) = 1.000000; -NODES[11337](IS_STRUCTURE,0) = 1.000000; -NODES[11338](IS_STRUCTURE,0) = 1.000000; -NODES[11340](IS_STRUCTURE,0) = 1.000000; -NODES[11343](IS_STRUCTURE,0) = 1.000000; -NODES[11353](IS_STRUCTURE,0) = 1.000000; -NODES[11354](IS_STRUCTURE,0) = 1.000000; -NODES[11355](IS_STRUCTURE,0) = 1.000000; -NODES[11356](IS_STRUCTURE,0) = 1.000000; -NODES[11357](IS_STRUCTURE,0) = 1.000000; -NODES[11361](IS_STRUCTURE,0) = 1.000000; -NODES[11368](IS_STRUCTURE,0) = 1.000000; -NODES[11370](IS_STRUCTURE,0) = 1.000000; -NODES[11372](IS_STRUCTURE,0) = 1.000000; -NODES[11384](IS_STRUCTURE,0) = 1.000000; -NODES[11408](IS_STRUCTURE,0) = 1.000000; -NODES[11414](IS_STRUCTURE,0) = 1.000000; -NODES[11426](IS_STRUCTURE,0) = 1.000000; -NODES[11427](IS_STRUCTURE,0) = 1.000000; -NODES[11431](IS_STRUCTURE,0) = 1.000000; -NODES[11437](IS_STRUCTURE,0) = 1.000000; -NODES[11464](IS_STRUCTURE,0) = 1.000000; -NODES[11465](IS_STRUCTURE,0) = 1.000000; -NODES[11466](IS_STRUCTURE,0) = 1.000000; -NODES[11467](IS_STRUCTURE,0) = 1.000000; -NODES[11468](IS_STRUCTURE,0) = 1.000000; -NODES[11469](IS_STRUCTURE,0) = 1.000000; -NODES[11471](IS_STRUCTURE,0) = 1.000000; -NODES[11472](IS_STRUCTURE,0) = 1.000000; -NODES[11476](IS_STRUCTURE,0) = 1.000000; -NODES[11486](IS_STRUCTURE,0) = 1.000000; -NODES[11487](IS_STRUCTURE,0) = 1.000000; -NODES[11491](IS_STRUCTURE,0) = 1.000000; -NODES[11493](IS_STRUCTURE,0) = 1.000000; -NODES[11494](IS_STRUCTURE,0) = 1.000000; -NODES[11502](IS_STRUCTURE,0) = 1.000000; -NODES[11507](IS_STRUCTURE,0) = 1.000000; -NODES[11510](IS_STRUCTURE,0) = 1.000000; -NODES[11513](IS_STRUCTURE,0) = 1.000000; -NODES[11527](IS_STRUCTURE,0) = 1.000000; -NODES[11528](IS_STRUCTURE,0) = 1.000000; -NODES[11531](IS_STRUCTURE,0) = 1.000000; -NODES[11550](IS_STRUCTURE,0) = 1.000000; -NODES[11563](IS_STRUCTURE,0) = 1.000000; -NODES[11564](IS_STRUCTURE,0) = 1.000000; -NODES[11569](IS_STRUCTURE,0) = 1.000000; -NODES[11574](IS_STRUCTURE,0) = 1.000000; -NODES[11584](IS_STRUCTURE,0) = 1.000000; -NODES[11585](IS_STRUCTURE,0) = 1.000000; -NODES[11586](IS_STRUCTURE,0) = 1.000000; -NODES[11596](IS_STRUCTURE,0) = 1.000000; -NODES[11597](IS_STRUCTURE,0) = 1.000000; -NODES[11598](IS_STRUCTURE,0) = 1.000000; -NODES[11599](IS_STRUCTURE,0) = 1.000000; -NODES[11600](IS_STRUCTURE,0) = 1.000000; -NODES[11606](IS_STRUCTURE,0) = 1.000000; -NODES[11624](IS_STRUCTURE,0) = 1.000000; -NODES[11625](IS_STRUCTURE,0) = 1.000000; -NODES[11626](IS_STRUCTURE,0) = 1.000000; -NODES[11627](IS_STRUCTURE,0) = 1.000000; -NODES[11633](IS_STRUCTURE,0) = 1.000000; -NODES[11642](IS_STRUCTURE,0) = 1.000000; -NODES[11644](IS_STRUCTURE,0) = 1.000000; -NODES[11651](IS_STRUCTURE,0) = 1.000000; -NODES[11655](IS_STRUCTURE,0) = 1.000000; -NODES[11659](IS_STRUCTURE,0) = 1.000000; -NODES[11660](IS_STRUCTURE,0) = 1.000000; -NODES[11661](IS_STRUCTURE,0) = 1.000000; -NODES[11662](IS_STRUCTURE,0) = 1.000000; -NODES[11667](IS_STRUCTURE,0) = 1.000000; -NODES[11677](IS_STRUCTURE,0) = 1.000000; -NODES[11678](IS_STRUCTURE,0) = 1.000000; -NODES[11679](IS_STRUCTURE,0) = 1.000000; -NODES[11684](IS_STRUCTURE,0) = 1.000000; -NODES[11685](IS_STRUCTURE,0) = 1.000000; -NODES[11695](IS_STRUCTURE,0) = 1.000000; -NODES[11700](IS_STRUCTURE,0) = 1.000000; -NODES[11711](IS_STRUCTURE,0) = 1.000000; -NODES[11720](IS_STRUCTURE,0) = 1.000000; -NODES[11734](IS_STRUCTURE,0) = 1.000000; -NODES[11736](IS_STRUCTURE,0) = 1.000000; -NODES[11738](IS_STRUCTURE,0) = 1.000000; -NODES[11740](IS_STRUCTURE,0) = 1.000000; -NODES[11751](IS_STRUCTURE,0) = 1.000000; -NODES[11752](IS_STRUCTURE,0) = 1.000000; -NODES[11753](IS_STRUCTURE,0) = 1.000000; -NODES[11754](IS_STRUCTURE,0) = 1.000000; -NODES[11761](IS_STRUCTURE,0) = 1.000000; -NODES[11792](IS_STRUCTURE,0) = 1.000000; -NODES[11793](IS_STRUCTURE,0) = 1.000000; -NODES[11803](IS_STRUCTURE,0) = 1.000000; -NODES[11806](IS_STRUCTURE,0) = 1.000000; -NODES[11817](IS_STRUCTURE,0) = 1.000000; -NODES[11822](IS_STRUCTURE,0) = 1.000000; -NODES[11826](IS_STRUCTURE,0) = 1.000000; -NODES[11827](IS_STRUCTURE,0) = 1.000000; -NODES[11828](IS_STRUCTURE,0) = 1.000000; -NODES[11831](IS_STRUCTURE,0) = 1.000000; -NODES[11836](IS_STRUCTURE,0) = 1.000000; -NODES[11845](IS_STRUCTURE,0) = 1.000000; -NODES[11846](IS_STRUCTURE,0) = 1.000000; -NODES[11865](IS_STRUCTURE,0) = 1.000000; -NODES[11867](IS_STRUCTURE,0) = 1.000000; -NODES[11873](IS_STRUCTURE,0) = 1.000000; -NODES[11877](IS_STRUCTURE,0) = 1.000000; -NODES[11910](IS_STRUCTURE,0) = 1.000000; -NODES[11915](IS_STRUCTURE,0) = 1.000000; -NODES[11916](IS_STRUCTURE,0) = 1.000000; -NODES[11919](IS_STRUCTURE,0) = 1.000000; -NODES[11937](IS_STRUCTURE,0) = 1.000000; -NODES[11938](IS_STRUCTURE,0) = 1.000000; -NODES[11939](IS_STRUCTURE,0) = 1.000000; -NODES[11940](IS_STRUCTURE,0) = 1.000000; -NODES[11953](IS_STRUCTURE,0) = 1.000000; -NODES[11960](IS_STRUCTURE,0) = 1.000000; -NODES[11961](IS_STRUCTURE,0) = 1.000000; -NODES[11967](IS_STRUCTURE,0) = 1.000000; -NODES[11971](IS_STRUCTURE,0) = 1.000000; -NODES[11985](IS_STRUCTURE,0) = 1.000000; -NODES[11991](IS_STRUCTURE,0) = 1.000000; -NODES[12003](IS_STRUCTURE,0) = 1.000000; -NODES[12006](IS_STRUCTURE,0) = 1.000000; -NODES[12013](IS_STRUCTURE,0) = 1.000000; -NODES[12028](IS_STRUCTURE,0) = 1.000000; -NODES[12030](IS_STRUCTURE,0) = 1.000000; -NODES[12033](IS_STRUCTURE,0) = 1.000000; -NODES[12042](IS_STRUCTURE,0) = 1.000000; -NODES[12052](IS_STRUCTURE,0) = 1.000000; -NODES[12067](IS_STRUCTURE,0) = 1.000000; -NODES[12070](IS_STRUCTURE,0) = 1.000000; -NODES[12072](IS_STRUCTURE,0) = 1.000000; -NODES[12081](IS_STRUCTURE,0) = 1.000000; -NODES[12084](IS_STRUCTURE,0) = 1.000000; -NODES[12086](IS_STRUCTURE,0) = 1.000000; -NODES[12094](IS_STRUCTURE,0) = 1.000000; -NODES[12095](IS_STRUCTURE,0) = 1.000000; -NODES[12096](IS_STRUCTURE,0) = 1.000000; -NODES[12115](IS_STRUCTURE,0) = 1.000000; -NODES[12117](IS_STRUCTURE,0) = 1.000000; -NODES[12134](IS_STRUCTURE,0) = 1.000000; -NODES[12135](IS_STRUCTURE,0) = 1.000000; -NODES[12136](IS_STRUCTURE,0) = 1.000000; -NODES[12137](IS_STRUCTURE,0) = 1.000000; -NODES[12138](IS_STRUCTURE,0) = 1.000000; -NODES[12139](IS_STRUCTURE,0) = 1.000000; -NODES[12143](IS_STRUCTURE,0) = 1.000000; -NODES[12151](IS_STRUCTURE,0) = 1.000000; -NODES[12169](IS_STRUCTURE,0) = 1.000000; -NODES[12170](IS_STRUCTURE,0) = 1.000000; -NODES[12171](IS_STRUCTURE,0) = 1.000000; -NODES[12172](IS_STRUCTURE,0) = 1.000000; -NODES[12183](IS_STRUCTURE,0) = 1.000000; -NODES[12192](IS_STRUCTURE,0) = 1.000000; -NODES[12197](IS_STRUCTURE,0) = 1.000000; -NODES[12211](IS_STRUCTURE,0) = 1.000000; -NODES[12221](IS_STRUCTURE,0) = 1.000000; -NODES[12225](IS_STRUCTURE,0) = 1.000000; -NODES[12230](IS_STRUCTURE,0) = 1.000000; -NODES[12235](IS_STRUCTURE,0) = 1.000000; -NODES[12265](IS_STRUCTURE,0) = 1.000000; -NODES[12266](IS_STRUCTURE,0) = 1.000000; -NODES[12270](IS_STRUCTURE,0) = 1.000000; -NODES[12294](IS_STRUCTURE,0) = 1.000000; -NODES[12309](IS_STRUCTURE,0) = 1.000000; -NODES[12314](IS_STRUCTURE,0) = 1.000000; -NODES[12315](IS_STRUCTURE,0) = 1.000000; -NODES[12316](IS_STRUCTURE,0) = 1.000000; -NODES[12318](IS_STRUCTURE,0) = 1.000000; -NODES[12328](IS_STRUCTURE,0) = 1.000000; -NODES[12329](IS_STRUCTURE,0) = 1.000000; -NODES[12337](IS_STRUCTURE,0) = 1.000000; -NODES[12338](IS_STRUCTURE,0) = 1.000000; -NODES[12339](IS_STRUCTURE,0) = 1.000000; -NODES[12340](IS_STRUCTURE,0) = 1.000000; -NODES[12342](IS_STRUCTURE,0) = 1.000000; -NODES[12349](IS_STRUCTURE,0) = 1.000000; -NODES[12355](IS_STRUCTURE,0) = 1.000000; -NODES[12360](IS_STRUCTURE,0) = 1.000000; -NODES[12361](IS_STRUCTURE,0) = 1.000000; -NODES[12362](IS_STRUCTURE,0) = 1.000000; -NODES[12363](IS_STRUCTURE,0) = 1.000000; -NODES[12371](IS_STRUCTURE,0) = 1.000000; -NODES[12375](IS_STRUCTURE,0) = 1.000000; -NODES[12395](IS_STRUCTURE,0) = 1.000000; -NODES[12396](IS_STRUCTURE,0) = 1.000000; -NODES[12397](IS_STRUCTURE,0) = 1.000000; -NODES[12399](IS_STRUCTURE,0) = 1.000000; -NODES[12400](IS_STRUCTURE,0) = 1.000000; -NODES[12431](IS_STRUCTURE,0) = 1.000000; -NODES[12434](IS_STRUCTURE,0) = 1.000000; -NODES[12439](IS_STRUCTURE,0) = 1.000000; -NODES[12446](IS_STRUCTURE,0) = 1.000000; -NODES[12449](IS_STRUCTURE,0) = 1.000000; -NODES[12451](IS_STRUCTURE,0) = 1.000000; -NODES[12452](IS_STRUCTURE,0) = 1.000000; -NODES[12453](IS_STRUCTURE,0) = 1.000000; -NODES[12456](IS_STRUCTURE,0) = 1.000000; -NODES[12458](IS_STRUCTURE,0) = 1.000000; -NODES[12460](IS_STRUCTURE,0) = 1.000000; -NODES[12461](IS_STRUCTURE,0) = 1.000000; -NODES[12470](IS_STRUCTURE,0) = 1.000000; -NODES[12471](IS_STRUCTURE,0) = 1.000000; -NODES[12487](IS_STRUCTURE,0) = 1.000000; -NODES[12488](IS_STRUCTURE,0) = 1.000000; -NODES[12489](IS_STRUCTURE,0) = 1.000000; -NODES[12498](IS_STRUCTURE,0) = 1.000000; -NODES[12508](IS_STRUCTURE,0) = 1.000000; -NODES[12509](IS_STRUCTURE,0) = 1.000000; -NODES[12523](IS_STRUCTURE,0) = 1.000000; -NODES[12529](IS_STRUCTURE,0) = 1.000000; -NODES[12536](IS_STRUCTURE,0) = 1.000000; -NODES[12548](IS_STRUCTURE,0) = 1.000000; -NODES[12558](IS_STRUCTURE,0) = 1.000000; -NODES[12559](IS_STRUCTURE,0) = 1.000000; -NODES[12564](IS_STRUCTURE,0) = 1.000000; -NODES[12567](IS_STRUCTURE,0) = 1.000000; -NODES[12574](IS_STRUCTURE,0) = 1.000000; -NODES[12596](IS_STRUCTURE,0) = 1.000000; -NODES[12597](IS_STRUCTURE,0) = 1.000000; -NODES[12598](IS_STRUCTURE,0) = 1.000000; -NODES[12599](IS_STRUCTURE,0) = 1.000000; -NODES[12602](IS_STRUCTURE,0) = 1.000000; -NODES[12604](IS_STRUCTURE,0) = 1.000000; -NODES[12618](IS_STRUCTURE,0) = 1.000000; -NODES[12621](IS_STRUCTURE,0) = 1.000000; -NODES[12628](IS_STRUCTURE,0) = 1.000000; -NODES[12630](IS_STRUCTURE,0) = 1.000000; -NODES[12632](IS_STRUCTURE,0) = 1.000000; -NODES[12638](IS_STRUCTURE,0) = 1.000000; -NODES[12653](IS_STRUCTURE,0) = 1.000000; -NODES[12663](IS_STRUCTURE,0) = 1.000000; -NODES[12692](IS_STRUCTURE,0) = 1.000000; -NODES[12693](IS_STRUCTURE,0) = 1.000000; -NODES[12697](IS_STRUCTURE,0) = 1.000000; -NODES[12701](IS_STRUCTURE,0) = 1.000000; -NODES[12710](IS_STRUCTURE,0) = 1.000000; -NODES[12716](IS_STRUCTURE,0) = 1.000000; -NODES[12724](IS_STRUCTURE,0) = 1.000000; -NODES[12725](IS_STRUCTURE,0) = 1.000000; -NODES[12727](IS_STRUCTURE,0) = 1.000000; -NODES[12743](IS_STRUCTURE,0) = 1.000000; -NODES[12744](IS_STRUCTURE,0) = 1.000000; -NODES[12760](IS_STRUCTURE,0) = 1.000000; -NODES[12768](IS_STRUCTURE,0) = 1.000000; -NODES[12774](IS_STRUCTURE,0) = 1.000000; -NODES[12775](IS_STRUCTURE,0) = 1.000000; -NODES[12796](IS_STRUCTURE,0) = 1.000000; -NODES[12798](IS_STRUCTURE,0) = 1.000000; -NODES[12810](IS_STRUCTURE,0) = 1.000000; -NODES[12820](IS_STRUCTURE,0) = 1.000000; -NODES[12821](IS_STRUCTURE,0) = 1.000000; -NODES[12832](IS_STRUCTURE,0) = 1.000000; -NODES[12834](IS_STRUCTURE,0) = 1.000000; -NODES[12842](IS_STRUCTURE,0) = 1.000000; -NODES[12852](IS_STRUCTURE,0) = 1.000000; -NODES[12853](IS_STRUCTURE,0) = 1.000000; -NODES[12854](IS_STRUCTURE,0) = 1.000000; -NODES[12860](IS_STRUCTURE,0) = 1.000000; -NODES[12861](IS_STRUCTURE,0) = 1.000000; -NODES[12862](IS_STRUCTURE,0) = 1.000000; -NODES[12863](IS_STRUCTURE,0) = 1.000000; -NODES[12885](IS_STRUCTURE,0) = 1.000000; -NODES[12912](IS_STRUCTURE,0) = 1.000000; -NODES[12914](IS_STRUCTURE,0) = 1.000000; -NODES[12915](IS_STRUCTURE,0) = 1.000000; -NODES[12925](IS_STRUCTURE,0) = 1.000000; -NODES[12941](IS_STRUCTURE,0) = 1.000000; -NODES[12946](IS_STRUCTURE,0) = 1.000000; -NODES[12951](IS_STRUCTURE,0) = 1.000000; -NODES[12954](IS_STRUCTURE,0) = 1.000000; -NODES[12964](IS_STRUCTURE,0) = 1.000000; -NODES[12966](IS_STRUCTURE,0) = 1.000000; -NODES[12968](IS_STRUCTURE,0) = 1.000000; -NODES[12983](IS_STRUCTURE,0) = 1.000000; -NODES[12991](IS_STRUCTURE,0) = 1.000000; -NODES[12999](IS_STRUCTURE,0) = 1.000000; -NODES[13018](IS_STRUCTURE,0) = 1.000000; -NODES[13029](IS_STRUCTURE,0) = 1.000000; -NODES[13033](IS_STRUCTURE,0) = 1.000000; -NODES[13039](IS_STRUCTURE,0) = 1.000000; -NODES[13042](IS_STRUCTURE,0) = 1.000000; -NODES[13054](IS_STRUCTURE,0) = 1.000000; -NODES[13056](IS_STRUCTURE,0) = 1.000000; -NODES[13065](IS_STRUCTURE,0) = 1.000000; -NODES[13073](IS_STRUCTURE,0) = 1.000000; -NODES[13074](IS_STRUCTURE,0) = 1.000000; -NODES[13086](IS_STRUCTURE,0) = 1.000000; -NODES[13087](IS_STRUCTURE,0) = 1.000000; -NODES[13099](IS_STRUCTURE,0) = 1.000000; -NODES[13104](IS_STRUCTURE,0) = 1.000000; -NODES[13105](IS_STRUCTURE,0) = 1.000000; -NODES[13106](IS_STRUCTURE,0) = 1.000000; -NODES[13107](IS_STRUCTURE,0) = 1.000000; -NODES[13114](IS_STRUCTURE,0) = 1.000000; -NODES[13115](IS_STRUCTURE,0) = 1.000000; -NODES[13124](IS_STRUCTURE,0) = 1.000000; -NODES[13128](IS_STRUCTURE,0) = 1.000000; -NODES[13129](IS_STRUCTURE,0) = 1.000000; -NODES[13130](IS_STRUCTURE,0) = 1.000000; -NODES[13131](IS_STRUCTURE,0) = 1.000000; -NODES[13132](IS_STRUCTURE,0) = 1.000000; -NODES[13133](IS_STRUCTURE,0) = 1.000000; -NODES[13151](IS_STRUCTURE,0) = 1.000000; -NODES[13152](IS_STRUCTURE,0) = 1.000000; -NODES[13155](IS_STRUCTURE,0) = 1.000000; -NODES[13165](IS_STRUCTURE,0) = 1.000000; -NODES[13168](IS_STRUCTURE,0) = 1.000000; -NODES[13169](IS_STRUCTURE,0) = 1.000000; -NODES[13191](IS_STRUCTURE,0) = 1.000000; -NODES[13195](IS_STRUCTURE,0) = 1.000000; -NODES[13201](IS_STRUCTURE,0) = 1.000000; -NODES[13202](IS_STRUCTURE,0) = 1.000000; -NODES[13208](IS_STRUCTURE,0) = 1.000000; -NODES[13209](IS_STRUCTURE,0) = 1.000000; -NODES[13216](IS_STRUCTURE,0) = 1.000000; -NODES[13223](IS_STRUCTURE,0) = 1.000000; -NODES[13235](IS_STRUCTURE,0) = 1.000000; -NODES[13236](IS_STRUCTURE,0) = 1.000000; -NODES[13242](IS_STRUCTURE,0) = 1.000000; -NODES[13255](IS_STRUCTURE,0) = 1.000000; -NODES[13260](IS_STRUCTURE,0) = 1.000000; -NODES[13280](IS_STRUCTURE,0) = 1.000000; -NODES[13283](IS_STRUCTURE,0) = 1.000000; -NODES[13289](IS_STRUCTURE,0) = 1.000000; -NODES[13290](IS_STRUCTURE,0) = 1.000000; -NODES[13299](IS_STRUCTURE,0) = 1.000000; -NODES[13312](IS_STRUCTURE,0) = 1.000000; -NODES[13314](IS_STRUCTURE,0) = 1.000000; -NODES[13326](IS_STRUCTURE,0) = 1.000000; -NODES[13338](IS_STRUCTURE,0) = 1.000000; -NODES[13344](IS_STRUCTURE,0) = 1.000000; -NODES[13347](IS_STRUCTURE,0) = 1.000000; -NODES[13348](IS_STRUCTURE,0) = 1.000000; -NODES[13351](IS_STRUCTURE,0) = 1.000000; -NODES[13360](IS_STRUCTURE,0) = 1.000000; -NODES[13367](IS_STRUCTURE,0) = 1.000000; -NODES[13372](IS_STRUCTURE,0) = 1.000000; -NODES[13378](IS_STRUCTURE,0) = 1.000000; -NODES[13388](IS_STRUCTURE,0) = 1.000000; -NODES[13395](IS_STRUCTURE,0) = 1.000000; -NODES[13417](IS_STRUCTURE,0) = 1.000000; -NODES[13420](IS_STRUCTURE,0) = 1.000000; -NODES[13423](IS_STRUCTURE,0) = 1.000000; -NODES[13424](IS_STRUCTURE,0) = 1.000000; -NODES[13425](IS_STRUCTURE,0) = 1.000000; -NODES[13426](IS_STRUCTURE,0) = 1.000000; -NODES[13436](IS_STRUCTURE,0) = 1.000000; -NODES[13437](IS_STRUCTURE,0) = 1.000000; -NODES[13439](IS_STRUCTURE,0) = 1.000000; -NODES[13447](IS_STRUCTURE,0) = 1.000000; -NODES[13452](IS_STRUCTURE,0) = 1.000000; -NODES[13455](IS_STRUCTURE,0) = 1.000000; -NODES[13466](IS_STRUCTURE,0) = 1.000000; -NODES[13469](IS_STRUCTURE,0) = 1.000000; -NODES[13486](IS_STRUCTURE,0) = 1.000000; -NODES[13493](IS_STRUCTURE,0) = 1.000000; -NODES[13497](IS_STRUCTURE,0) = 1.000000; -NODES[13513](IS_STRUCTURE,0) = 1.000000; -NODES[13524](IS_STRUCTURE,0) = 1.000000; -NODES[13531](IS_STRUCTURE,0) = 1.000000; -NODES[13537](IS_STRUCTURE,0) = 1.000000; -NODES[13538](IS_STRUCTURE,0) = 1.000000; -NODES[13540](IS_STRUCTURE,0) = 1.000000; -NODES[13559](IS_STRUCTURE,0) = 1.000000; -NODES[13562](IS_STRUCTURE,0) = 1.000000; -NODES[13568](IS_STRUCTURE,0) = 1.000000; -NODES[13580](IS_STRUCTURE,0) = 1.000000; -NODES[13595](IS_STRUCTURE,0) = 1.000000; -NODES[13601](IS_STRUCTURE,0) = 1.000000; -NODES[13616](IS_STRUCTURE,0) = 1.000000; -NODES[13618](IS_STRUCTURE,0) = 1.000000; -NODES[13620](IS_STRUCTURE,0) = 1.000000; -NODES[13635](IS_STRUCTURE,0) = 1.000000; -NODES[13638](IS_STRUCTURE,0) = 1.000000; -NODES[13650](IS_STRUCTURE,0) = 1.000000; -NODES[13662](IS_STRUCTURE,0) = 1.000000; -NODES[13678](IS_STRUCTURE,0) = 1.000000; -NODES[13679](IS_STRUCTURE,0) = 1.000000; -NODES[13690](IS_STRUCTURE,0) = 1.000000; -NODES[13692](IS_STRUCTURE,0) = 1.000000; -NODES[13696](IS_STRUCTURE,0) = 1.000000; -NODES[13706](IS_STRUCTURE,0) = 1.000000; -NODES[13712](IS_STRUCTURE,0) = 1.000000; -NODES[13714](IS_STRUCTURE,0) = 1.000000; -NODES[13723](IS_STRUCTURE,0) = 1.000000; -NODES[13724](IS_STRUCTURE,0) = 1.000000; -NODES[13725](IS_STRUCTURE,0) = 1.000000; -NODES[13726](IS_STRUCTURE,0) = 1.000000; -NODES[13727](IS_STRUCTURE,0) = 1.000000; -NODES[13728](IS_STRUCTURE,0) = 1.000000; -NODES[13751](IS_STRUCTURE,0) = 1.000000; -NODES[13774](IS_STRUCTURE,0) = 1.000000; -NODES[13796](IS_STRUCTURE,0) = 1.000000; -NODES[13801](IS_STRUCTURE,0) = 1.000000; -NODES[13802](IS_STRUCTURE,0) = 1.000000; -NODES[13821](IS_STRUCTURE,0) = 1.000000; -NODES[13824](IS_STRUCTURE,0) = 1.000000; -NODES[13831](IS_STRUCTURE,0) = 1.000000; -NODES[13833](IS_STRUCTURE,0) = 1.000000; -NODES[13834](IS_STRUCTURE,0) = 1.000000; -NODES[13838](IS_STRUCTURE,0) = 1.000000; -NODES[13843](IS_STRUCTURE,0) = 1.000000; -NODES[13852](IS_STRUCTURE,0) = 1.000000; -NODES[13862](IS_STRUCTURE,0) = 1.000000; -NODES[13865](IS_STRUCTURE,0) = 1.000000; -NODES[13867](IS_STRUCTURE,0) = 1.000000; -NODES[13889](IS_STRUCTURE,0) = 1.000000; -NODES[13890](IS_STRUCTURE,0) = 1.000000; -NODES[13893](IS_STRUCTURE,0) = 1.000000; -NODES[13899](IS_STRUCTURE,0) = 1.000000; -NODES[13904](IS_STRUCTURE,0) = 1.000000; -NODES[13905](IS_STRUCTURE,0) = 1.000000; -NODES[13908](IS_STRUCTURE,0) = 1.000000; -NODES[13909](IS_STRUCTURE,0) = 1.000000; -NODES[13910](IS_STRUCTURE,0) = 1.000000; -NODES[13916](IS_STRUCTURE,0) = 1.000000; -NODES[13918](IS_STRUCTURE,0) = 1.000000; -NODES[13923](IS_STRUCTURE,0) = 1.000000; -NODES[13931](IS_STRUCTURE,0) = 1.000000; -NODES[13932](IS_STRUCTURE,0) = 1.000000; -NODES[13935](IS_STRUCTURE,0) = 1.000000; -NODES[13939](IS_STRUCTURE,0) = 1.000000; -NODES[13945](IS_STRUCTURE,0) = 1.000000; -NODES[13950](IS_STRUCTURE,0) = 1.000000; -NODES[13956](IS_STRUCTURE,0) = 1.000000; -NODES[13977](IS_STRUCTURE,0) = 1.000000; -NODES[13979](IS_STRUCTURE,0) = 1.000000; -NODES[13980](IS_STRUCTURE,0) = 1.000000; -NODES[13987](IS_STRUCTURE,0) = 1.000000; -NODES[13991](IS_STRUCTURE,0) = 1.000000; -NODES[14006](IS_STRUCTURE,0) = 1.000000; -NODES[14007](IS_STRUCTURE,0) = 1.000000; -NODES[14016](IS_STRUCTURE,0) = 1.000000; -NODES[14017](IS_STRUCTURE,0) = 1.000000; -NODES[14034](IS_STRUCTURE,0) = 1.000000; -NODES[14035](IS_STRUCTURE,0) = 1.000000; -NODES[14036](IS_STRUCTURE,0) = 1.000000; -NODES[14037](IS_STRUCTURE,0) = 1.000000; -NODES[14038](IS_STRUCTURE,0) = 1.000000; -NODES[14052](IS_STRUCTURE,0) = 1.000000; -NODES[14054](IS_STRUCTURE,0) = 1.000000; -NODES[14056](IS_STRUCTURE,0) = 1.000000; -NODES[14064](IS_STRUCTURE,0) = 1.000000; -NODES[14073](IS_STRUCTURE,0) = 1.000000; -NODES[14074](IS_STRUCTURE,0) = 1.000000; -NODES[14076](IS_STRUCTURE,0) = 1.000000; -NODES[14091](IS_STRUCTURE,0) = 1.000000; -NODES[14113](IS_STRUCTURE,0) = 1.000000; -NODES[14116](IS_STRUCTURE,0) = 1.000000; -NODES[14121](IS_STRUCTURE,0) = 1.000000; -NODES[14124](IS_STRUCTURE,0) = 1.000000; -NODES[14146](IS_STRUCTURE,0) = 1.000000; -NODES[14167](IS_STRUCTURE,0) = 1.000000; -NODES[14175](IS_STRUCTURE,0) = 1.000000; -NODES[14179](IS_STRUCTURE,0) = 1.000000; -NODES[14189](IS_STRUCTURE,0) = 1.000000; -NODES[14197](IS_STRUCTURE,0) = 1.000000; -NODES[14203](IS_STRUCTURE,0) = 1.000000; -NODES[14212](IS_STRUCTURE,0) = 1.000000; -NODES[14225](IS_STRUCTURE,0) = 1.000000; -NODES[14228](IS_STRUCTURE,0) = 1.000000; -NODES[14232](IS_STRUCTURE,0) = 1.000000; -NODES[14235](IS_STRUCTURE,0) = 1.000000; -NODES[14236](IS_STRUCTURE,0) = 1.000000; -NODES[14239](IS_STRUCTURE,0) = 1.000000; -NODES[14242](IS_STRUCTURE,0) = 1.000000; -NODES[14281](IS_STRUCTURE,0) = 1.000000; -NODES[14282](IS_STRUCTURE,0) = 1.000000; -NODES[14284](IS_STRUCTURE,0) = 1.000000; -NODES[14288](IS_STRUCTURE,0) = 1.000000; -NODES[14295](IS_STRUCTURE,0) = 1.000000; -NODES[14303](IS_STRUCTURE,0) = 1.000000; -NODES[14306](IS_STRUCTURE,0) = 1.000000; -NODES[14307](IS_STRUCTURE,0) = 1.000000; -NODES[14308](IS_STRUCTURE,0) = 1.000000; -NODES[14314](IS_STRUCTURE,0) = 1.000000; -NODES[14317](IS_STRUCTURE,0) = 1.000000; -NODES[14323](IS_STRUCTURE,0) = 1.000000; -NODES[14326](IS_STRUCTURE,0) = 1.000000; -NODES[14328](IS_STRUCTURE,0) = 1.000000; -NODES[14344](IS_STRUCTURE,0) = 1.000000; -NODES[14345](IS_STRUCTURE,0) = 1.000000; -NODES[14346](IS_STRUCTURE,0) = 1.000000; -NODES[14347](IS_STRUCTURE,0) = 1.000000; -NODES[14376](IS_STRUCTURE,0) = 1.000000; -NODES[14378](IS_STRUCTURE,0) = 1.000000; -NODES[14385](IS_STRUCTURE,0) = 1.000000; -NODES[14386](IS_STRUCTURE,0) = 1.000000; -NODES[14399](IS_STRUCTURE,0) = 1.000000; -NODES[14402](IS_STRUCTURE,0) = 1.000000; -NODES[14404](IS_STRUCTURE,0) = 1.000000; -NODES[14405](IS_STRUCTURE,0) = 1.000000; -NODES[14410](IS_STRUCTURE,0) = 1.000000; -NODES[14418](IS_STRUCTURE,0) = 1.000000; -NODES[14431](IS_STRUCTURE,0) = 1.000000; -NODES[14442](IS_STRUCTURE,0) = 1.000000; -NODES[14449](IS_STRUCTURE,0) = 1.000000; -NODES[14450](IS_STRUCTURE,0) = 1.000000; -NODES[14459](IS_STRUCTURE,0) = 1.000000; -NODES[14473](IS_STRUCTURE,0) = 1.000000; -NODES[14519](IS_STRUCTURE,0) = 1.000000; -NODES[14522](IS_STRUCTURE,0) = 1.000000; -NODES[14524](IS_STRUCTURE,0) = 1.000000; -NODES[14532](IS_STRUCTURE,0) = 1.000000; -NODES[14536](IS_STRUCTURE,0) = 1.000000; -NODES[14542](IS_STRUCTURE,0) = 1.000000; -NODES[14551](IS_STRUCTURE,0) = 1.000000; -NODES[14552](IS_STRUCTURE,0) = 1.000000; -NODES[14556](IS_STRUCTURE,0) = 1.000000; -NODES[14558](IS_STRUCTURE,0) = 1.000000; -NODES[14563](IS_STRUCTURE,0) = 1.000000; -NODES[14590](IS_STRUCTURE,0) = 1.000000; -NODES[14605](IS_STRUCTURE,0) = 1.000000; -NODES[14609](IS_STRUCTURE,0) = 1.000000; -NODES[14619](IS_STRUCTURE,0) = 1.000000; -NODES[14620](IS_STRUCTURE,0) = 1.000000; -NODES[14644](IS_STRUCTURE,0) = 1.000000; -NODES[14646](IS_STRUCTURE,0) = 1.000000; -NODES[14660](IS_STRUCTURE,0) = 1.000000; -NODES[14662](IS_STRUCTURE,0) = 1.000000; -NODES[14663](IS_STRUCTURE,0) = 1.000000; -NODES[14668](IS_STRUCTURE,0) = 1.000000; -NODES[14669](IS_STRUCTURE,0) = 1.000000; -NODES[14680](IS_STRUCTURE,0) = 1.000000; -NODES[14681](IS_STRUCTURE,0) = 1.000000; -NODES[14682](IS_STRUCTURE,0) = 1.000000; -NODES[14683](IS_STRUCTURE,0) = 1.000000; -NODES[14684](IS_STRUCTURE,0) = 1.000000; -NODES[14689](IS_STRUCTURE,0) = 1.000000; -NODES[14690](IS_STRUCTURE,0) = 1.000000; -NODES[14705](IS_STRUCTURE,0) = 1.000000; -NODES[14719](IS_STRUCTURE,0) = 1.000000; -NODES[14723](IS_STRUCTURE,0) = 1.000000; -NODES[14726](IS_STRUCTURE,0) = 1.000000; -NODES[14731](IS_STRUCTURE,0) = 1.000000; -NODES[14732](IS_STRUCTURE,0) = 1.000000; -NODES[14734](IS_STRUCTURE,0) = 1.000000; -NODES[14736](IS_STRUCTURE,0) = 1.000000; -NODES[14737](IS_STRUCTURE,0) = 1.000000; -NODES[14745](IS_STRUCTURE,0) = 1.000000; -NODES[14750](IS_STRUCTURE,0) = 1.000000; -NODES[14763](IS_STRUCTURE,0) = 1.000000; -NODES[14765](IS_STRUCTURE,0) = 1.000000; -NODES[14766](IS_STRUCTURE,0) = 1.000000; -NODES[14768](IS_STRUCTURE,0) = 1.000000; -NODES[14776](IS_STRUCTURE,0) = 1.000000; -NODES[14782](IS_STRUCTURE,0) = 1.000000; -NODES[14792](IS_STRUCTURE,0) = 1.000000; -NODES[14794](IS_STRUCTURE,0) = 1.000000; -NODES[14797](IS_STRUCTURE,0) = 1.000000; -NODES[14800](IS_STRUCTURE,0) = 1.000000; -NODES[14813](IS_STRUCTURE,0) = 1.000000; -NODES[14817](IS_STRUCTURE,0) = 1.000000; -NODES[14823](IS_STRUCTURE,0) = 1.000000; -NODES[14833](IS_STRUCTURE,0) = 1.000000; -NODES[14838](IS_STRUCTURE,0) = 1.000000; -NODES[14841](IS_STRUCTURE,0) = 1.000000; -NODES[14852](IS_STRUCTURE,0) = 1.000000; -NODES[14884](IS_STRUCTURE,0) = 1.000000; -NODES[14889](IS_STRUCTURE,0) = 1.000000; -NODES[14893](IS_STRUCTURE,0) = 1.000000; -NODES[14895](IS_STRUCTURE,0) = 1.000000; -NODES[14899](IS_STRUCTURE,0) = 1.000000; -NODES[14906](IS_STRUCTURE,0) = 1.000000; -NODES[14911](IS_STRUCTURE,0) = 1.000000; -NODES[14912](IS_STRUCTURE,0) = 1.000000; -NODES[14913](IS_STRUCTURE,0) = 1.000000; -NODES[14922](IS_STRUCTURE,0) = 1.000000; -NODES[14928](IS_STRUCTURE,0) = 1.000000; -NODES[14964](IS_STRUCTURE,0) = 1.000000; -NODES[14977](IS_STRUCTURE,0) = 1.000000; -NODES[14984](IS_STRUCTURE,0) = 1.000000; -NODES[14988](IS_STRUCTURE,0) = 1.000000; -NODES[14989](IS_STRUCTURE,0) = 1.000000; -NODES[14990](IS_STRUCTURE,0) = 1.000000; -NODES[14991](IS_STRUCTURE,0) = 1.000000; -NODES[14993](IS_STRUCTURE,0) = 1.000000; -NODES[14995](IS_STRUCTURE,0) = 1.000000; -NODES[14999](IS_STRUCTURE,0) = 1.000000; -NODES[15004](IS_STRUCTURE,0) = 1.000000; -NODES[15005](IS_STRUCTURE,0) = 1.000000; -NODES[15027](IS_STRUCTURE,0) = 1.000000; -NODES[15028](IS_STRUCTURE,0) = 1.000000; -NODES[15029](IS_STRUCTURE,0) = 1.000000; -NODES[15032](IS_STRUCTURE,0) = 1.000000; -NODES[15040](IS_STRUCTURE,0) = 1.000000; -NODES[15059](IS_STRUCTURE,0) = 1.000000; -NODES[15065](IS_STRUCTURE,0) = 1.000000; -NODES[15068](IS_STRUCTURE,0) = 1.000000; -NODES[15078](IS_STRUCTURE,0) = 1.000000; -NODES[15084](IS_STRUCTURE,0) = 1.000000; -NODES[15088](IS_STRUCTURE,0) = 1.000000; -NODES[15102](IS_STRUCTURE,0) = 1.000000; -NODES[15103](IS_STRUCTURE,0) = 1.000000; -NODES[15114](IS_STRUCTURE,0) = 1.000000; -NODES[15123](IS_STRUCTURE,0) = 1.000000; -NODES[15133](IS_STRUCTURE,0) = 1.000000; -NODES[15142](IS_STRUCTURE,0) = 1.000000; -NODES[15148](IS_STRUCTURE,0) = 1.000000; -NODES[15149](IS_STRUCTURE,0) = 1.000000; -NODES[15151](IS_STRUCTURE,0) = 1.000000; -NODES[15170](IS_STRUCTURE,0) = 1.000000; -NODES[15176](IS_STRUCTURE,0) = 1.000000; -NODES[15179](IS_STRUCTURE,0) = 1.000000; -NODES[15185](IS_STRUCTURE,0) = 1.000000; -NODES[15190](IS_STRUCTURE,0) = 1.000000; -NODES[15194](IS_STRUCTURE,0) = 1.000000; -NODES[15195](IS_STRUCTURE,0) = 1.000000; -NODES[15198](IS_STRUCTURE,0) = 1.000000; -NODES[15206](IS_STRUCTURE,0) = 1.000000; -NODES[15207](IS_STRUCTURE,0) = 1.000000; -NODES[15218](IS_STRUCTURE,0) = 1.000000; -NODES[15227](IS_STRUCTURE,0) = 1.000000; -NODES[15233](IS_STRUCTURE,0) = 1.000000; -NODES[15253](IS_STRUCTURE,0) = 1.000000; -NODES[15262](IS_STRUCTURE,0) = 1.000000; -NODES[15264](IS_STRUCTURE,0) = 1.000000; -NODES[15265](IS_STRUCTURE,0) = 1.000000; -NODES[15266](IS_STRUCTURE,0) = 1.000000; -NODES[15270](IS_STRUCTURE,0) = 1.000000; -NODES[15273](IS_STRUCTURE,0) = 1.000000; -NODES[15280](IS_STRUCTURE,0) = 1.000000; -NODES[15283](IS_STRUCTURE,0) = 1.000000; -NODES[15285](IS_STRUCTURE,0) = 1.000000; -NODES[15288](IS_STRUCTURE,0) = 1.000000; -NODES[15301](IS_STRUCTURE,0) = 1.000000; -NODES[15309](IS_STRUCTURE,0) = 1.000000; -NODES[15310](IS_STRUCTURE,0) = 1.000000; -NODES[15311](IS_STRUCTURE,0) = 1.000000; -NODES[15330](IS_STRUCTURE,0) = 1.000000; -NODES[15335](IS_STRUCTURE,0) = 1.000000; -NODES[15337](IS_STRUCTURE,0) = 1.000000; -NODES[15342](IS_STRUCTURE,0) = 1.000000; -NODES[15349](IS_STRUCTURE,0) = 1.000000; -NODES[15355](IS_STRUCTURE,0) = 1.000000; -NODES[15356](IS_STRUCTURE,0) = 1.000000; -NODES[15361](IS_STRUCTURE,0) = 1.000000; -NODES[15372](IS_STRUCTURE,0) = 1.000000; -NODES[15375](IS_STRUCTURE,0) = 1.000000; -NODES[15397](IS_STRUCTURE,0) = 1.000000; -NODES[15406](IS_STRUCTURE,0) = 1.000000; -NODES[15408](IS_STRUCTURE,0) = 1.000000; -NODES[15409](IS_STRUCTURE,0) = 1.000000; -NODES[15414](IS_STRUCTURE,0) = 1.000000; -NODES[15418](IS_STRUCTURE,0) = 1.000000; -NODES[15430](IS_STRUCTURE,0) = 1.000000; -NODES[15440](IS_STRUCTURE,0) = 1.000000; -NODES[15447](IS_STRUCTURE,0) = 1.000000; -NODES[15448](IS_STRUCTURE,0) = 1.000000; -NODES[15451](IS_STRUCTURE,0) = 1.000000; -NODES[15460](IS_STRUCTURE,0) = 1.000000; -NODES[15469](IS_STRUCTURE,0) = 1.000000; -NODES[15471](IS_STRUCTURE,0) = 1.000000; -NODES[15472](IS_STRUCTURE,0) = 1.000000; -NODES[15481](IS_STRUCTURE,0) = 1.000000; -NODES[15482](IS_STRUCTURE,0) = 1.000000; -NODES[15501](IS_STRUCTURE,0) = 1.000000; -NODES[15504](IS_STRUCTURE,0) = 1.000000; -NODES[15512](IS_STRUCTURE,0) = 1.000000; -NODES[15518](IS_STRUCTURE,0) = 1.000000; -NODES[15521](IS_STRUCTURE,0) = 1.000000; -NODES[15529](IS_STRUCTURE,0) = 1.000000; -NODES[15540](IS_STRUCTURE,0) = 1.000000; -NODES[15542](IS_STRUCTURE,0) = 1.000000; -NODES[15544](IS_STRUCTURE,0) = 1.000000; -NODES[15546](IS_STRUCTURE,0) = 1.000000; -NODES[15551](IS_STRUCTURE,0) = 1.000000; -NODES[15552](IS_STRUCTURE,0) = 1.000000; -NODES[15554](IS_STRUCTURE,0) = 1.000000; -NODES[15560](IS_STRUCTURE,0) = 1.000000; -NODES[15561](IS_STRUCTURE,0) = 1.000000; -NODES[15583](IS_STRUCTURE,0) = 1.000000; -NODES[15595](IS_STRUCTURE,0) = 1.000000; -NODES[15597](IS_STRUCTURE,0) = 1.000000; -NODES[15601](IS_STRUCTURE,0) = 1.000000; -NODES[15602](IS_STRUCTURE,0) = 1.000000; -NODES[15607](IS_STRUCTURE,0) = 1.000000; -NODES[15608](IS_STRUCTURE,0) = 1.000000; -NODES[15613](IS_STRUCTURE,0) = 1.000000; -NODES[15618](IS_STRUCTURE,0) = 1.000000; -NODES[15619](IS_STRUCTURE,0) = 1.000000; -NODES[15620](IS_STRUCTURE,0) = 1.000000; -NODES[15621](IS_STRUCTURE,0) = 1.000000; -NODES[15623](IS_STRUCTURE,0) = 1.000000; -NODES[15646](IS_STRUCTURE,0) = 1.000000; -NODES[15659](IS_STRUCTURE,0) = 1.000000; -NODES[15660](IS_STRUCTURE,0) = 1.000000; -NODES[15661](IS_STRUCTURE,0) = 1.000000; -NODES[15662](IS_STRUCTURE,0) = 1.000000; -NODES[15663](IS_STRUCTURE,0) = 1.000000; -NODES[15681](IS_STRUCTURE,0) = 1.000000; -NODES[15698](IS_STRUCTURE,0) = 1.000000; -NODES[15708](IS_STRUCTURE,0) = 1.000000; -NODES[15711](IS_STRUCTURE,0) = 1.000000; -NODES[15723](IS_STRUCTURE,0) = 1.000000; -NODES[15732](IS_STRUCTURE,0) = 1.000000; -NODES[15734](IS_STRUCTURE,0) = 1.000000; -NODES[15743](IS_STRUCTURE,0) = 1.000000; -NODES[15750](IS_STRUCTURE,0) = 1.000000; -NODES[15752](IS_STRUCTURE,0) = 1.000000; -NODES[15764](IS_STRUCTURE,0) = 1.000000; -NODES[15769](IS_STRUCTURE,0) = 1.000000; -NODES[15773](IS_STRUCTURE,0) = 1.000000; -NODES[15777](IS_STRUCTURE,0) = 1.000000; -NODES[15779](IS_STRUCTURE,0) = 1.000000; -NODES[15781](IS_STRUCTURE,0) = 1.000000; -NODES[15785](IS_STRUCTURE,0) = 1.000000; -NODES[15799](IS_STRUCTURE,0) = 1.000000; -NODES[15817](IS_STRUCTURE,0) = 1.000000; -NODES[15819](IS_STRUCTURE,0) = 1.000000; -NODES[15820](IS_STRUCTURE,0) = 1.000000; -NODES[15832](IS_STRUCTURE,0) = 1.000000; -NODES[15844](IS_STRUCTURE,0) = 1.000000; -NODES[15857](IS_STRUCTURE,0) = 1.000000; -NODES[15861](IS_STRUCTURE,0) = 1.000000; -NODES[15863](IS_STRUCTURE,0) = 1.000000; -NODES[15869](IS_STRUCTURE,0) = 1.000000; -NODES[15883](IS_STRUCTURE,0) = 1.000000; -NODES[15890](IS_STRUCTURE,0) = 1.000000; -NODES[15894](IS_STRUCTURE,0) = 1.000000; -NODES[15895](IS_STRUCTURE,0) = 1.000000; -NODES[15896](IS_STRUCTURE,0) = 1.000000; -NODES[15901](IS_STRUCTURE,0) = 1.000000; -NODES[15902](IS_STRUCTURE,0) = 1.000000; -NODES[15912](IS_STRUCTURE,0) = 1.000000; -NODES[15917](IS_STRUCTURE,0) = 1.000000; -NODES[15920](IS_STRUCTURE,0) = 1.000000; -NODES[15923](IS_STRUCTURE,0) = 1.000000; -NODES[15924](IS_STRUCTURE,0) = 1.000000; -NODES[15926](IS_STRUCTURE,0) = 1.000000; -NODES[15932](IS_STRUCTURE,0) = 1.000000; -NODES[15934](IS_STRUCTURE,0) = 1.000000; -NODES[15937](IS_STRUCTURE,0) = 1.000000; -NODES[15938](IS_STRUCTURE,0) = 1.000000; -NODES[15940](IS_STRUCTURE,0) = 1.000000; -NODES[15941](IS_STRUCTURE,0) = 1.000000; -NODES[15966](IS_STRUCTURE,0) = 1.000000; -NODES[15967](IS_STRUCTURE,0) = 1.000000; -NODES[15972](IS_STRUCTURE,0) = 1.000000; -NODES[15980](IS_STRUCTURE,0) = 1.000000; -NODES[15982](IS_STRUCTURE,0) = 1.000000; -NODES[15994](IS_STRUCTURE,0) = 1.000000; -NODES[15995](IS_STRUCTURE,0) = 1.000000; -NODES[16026](IS_STRUCTURE,0) = 1.000000; -NODES[16027](IS_STRUCTURE,0) = 1.000000; -NODES[16028](IS_STRUCTURE,0) = 1.000000; -NODES[16031](IS_STRUCTURE,0) = 1.000000; -NODES[16036](IS_STRUCTURE,0) = 1.000000; -NODES[16037](IS_STRUCTURE,0) = 1.000000; -NODES[16039](IS_STRUCTURE,0) = 1.000000; -NODES[16042](IS_STRUCTURE,0) = 1.000000; -NODES[16047](IS_STRUCTURE,0) = 1.000000; -NODES[16048](IS_STRUCTURE,0) = 1.000000; -NODES[16061](IS_STRUCTURE,0) = 1.000000; -NODES[16062](IS_STRUCTURE,0) = 1.000000; -NODES[16076](IS_STRUCTURE,0) = 1.000000; -NODES[16080](IS_STRUCTURE,0) = 1.000000; -NODES[16083](IS_STRUCTURE,0) = 1.000000; -NODES[16090](IS_STRUCTURE,0) = 1.000000; -NODES[16091](IS_STRUCTURE,0) = 1.000000; -NODES[16111](IS_STRUCTURE,0) = 1.000000; -NODES[16114](IS_STRUCTURE,0) = 1.000000; -NODES[16118](IS_STRUCTURE,0) = 1.000000; -NODES[16127](IS_STRUCTURE,0) = 1.000000; -NODES[16129](IS_STRUCTURE,0) = 1.000000; -NODES[16137](IS_STRUCTURE,0) = 1.000000; -NODES[16144](IS_STRUCTURE,0) = 1.000000; -NODES[16153](IS_STRUCTURE,0) = 1.000000; -NODES[16156](IS_STRUCTURE,0) = 1.000000; -NODES[16161](IS_STRUCTURE,0) = 1.000000; -NODES[16163](IS_STRUCTURE,0) = 1.000000; -NODES[16165](IS_STRUCTURE,0) = 1.000000; -NODES[16168](IS_STRUCTURE,0) = 1.000000; -NODES[16169](IS_STRUCTURE,0) = 1.000000; -NODES[16181](IS_STRUCTURE,0) = 1.000000; -NODES[16196](IS_STRUCTURE,0) = 1.000000; -NODES[16204](IS_STRUCTURE,0) = 1.000000; -NODES[16210](IS_STRUCTURE,0) = 1.000000; -NODES[16216](IS_STRUCTURE,0) = 1.000000; -NODES[16220](IS_STRUCTURE,0) = 1.000000; -NODES[16223](IS_STRUCTURE,0) = 1.000000; -NODES[16224](IS_STRUCTURE,0) = 1.000000; -NODES[16230](IS_STRUCTURE,0) = 1.000000; -NODES[16239](IS_STRUCTURE,0) = 1.000000; -NODES[16244](IS_STRUCTURE,0) = 1.000000; -NODES[16249](IS_STRUCTURE,0) = 1.000000; -NODES[16261](IS_STRUCTURE,0) = 1.000000; -NODES[16262](IS_STRUCTURE,0) = 1.000000; -NODES[16267](IS_STRUCTURE,0) = 1.000000; -NODES[16269](IS_STRUCTURE,0) = 1.000000; -NODES[16291](IS_STRUCTURE,0) = 1.000000; -NODES[16292](IS_STRUCTURE,0) = 1.000000; -NODES[16293](IS_STRUCTURE,0) = 1.000000; -NODES[16296](IS_STRUCTURE,0) = 1.000000; -NODES[16300](IS_STRUCTURE,0) = 1.000000; -NODES[16302](IS_STRUCTURE,0) = 1.000000; -NODES[16310](IS_STRUCTURE,0) = 1.000000; -NODES[16321](IS_STRUCTURE,0) = 1.000000; -NODES[16326](IS_STRUCTURE,0) = 1.000000; -NODES[16329](IS_STRUCTURE,0) = 1.000000; -NODES[16334](IS_STRUCTURE,0) = 1.000000; -NODES[16343](IS_STRUCTURE,0) = 1.000000; -NODES[16344](IS_STRUCTURE,0) = 1.000000; -NODES[16346](IS_STRUCTURE,0) = 1.000000; -NODES[16352](IS_STRUCTURE,0) = 1.000000; -NODES[16353](IS_STRUCTURE,0) = 1.000000; -NODES[16357](IS_STRUCTURE,0) = 1.000000; -NODES[16359](IS_STRUCTURE,0) = 1.000000; -NODES[16376](IS_STRUCTURE,0) = 1.000000; -NODES[16387](IS_STRUCTURE,0) = 1.000000; -NODES[16391](IS_STRUCTURE,0) = 1.000000; -NODES[16392](IS_STRUCTURE,0) = 1.000000; -NODES[16393](IS_STRUCTURE,0) = 1.000000; -NODES[16398](IS_STRUCTURE,0) = 1.000000; -NODES[16406](IS_STRUCTURE,0) = 1.000000; -NODES[16411](IS_STRUCTURE,0) = 1.000000; -NODES[16412](IS_STRUCTURE,0) = 1.000000; -NODES[16413](IS_STRUCTURE,0) = 1.000000; -NODES[16420](IS_STRUCTURE,0) = 1.000000; -NODES[16439](IS_STRUCTURE,0) = 1.000000; -NODES[16442](IS_STRUCTURE,0) = 1.000000; -NODES[16448](IS_STRUCTURE,0) = 1.000000; -NODES[16451](IS_STRUCTURE,0) = 1.000000; -NODES[16460](IS_STRUCTURE,0) = 1.000000; -NODES[16461](IS_STRUCTURE,0) = 1.000000; -NODES[16462](IS_STRUCTURE,0) = 1.000000; -NODES[16478](IS_STRUCTURE,0) = 1.000000; -NODES[16480](IS_STRUCTURE,0) = 1.000000; -NODES[16483](IS_STRUCTURE,0) = 1.000000; -NODES[16494](IS_STRUCTURE,0) = 1.000000; -NODES[16495](IS_STRUCTURE,0) = 1.000000; -NODES[16497](IS_STRUCTURE,0) = 1.000000; -NODES[16501](IS_STRUCTURE,0) = 1.000000; -NODES[16503](IS_STRUCTURE,0) = 1.000000; -NODES[16516](IS_STRUCTURE,0) = 1.000000; -NODES[16526](IS_STRUCTURE,0) = 1.000000; -NODES[16529](IS_STRUCTURE,0) = 1.000000; -NODES[16531](IS_STRUCTURE,0) = 1.000000; -NODES[16532](IS_STRUCTURE,0) = 1.000000; -NODES[16534](IS_STRUCTURE,0) = 1.000000; -NODES[16536](IS_STRUCTURE,0) = 1.000000; -NODES[16539](IS_STRUCTURE,0) = 1.000000; -NODES[16540](IS_STRUCTURE,0) = 1.000000; -NODES[16550](IS_STRUCTURE,0) = 1.000000; -NODES[16553](IS_STRUCTURE,0) = 1.000000; -NODES[16556](IS_STRUCTURE,0) = 1.000000; -NODES[16566](IS_STRUCTURE,0) = 1.000000; -NODES[16569](IS_STRUCTURE,0) = 1.000000; -NODES[16577](IS_STRUCTURE,0) = 1.000000; -NODES[16585](IS_STRUCTURE,0) = 1.000000; -NODES[16586](IS_STRUCTURE,0) = 1.000000; -NODES[16588](IS_STRUCTURE,0) = 1.000000; -NODES[16621](IS_STRUCTURE,0) = 1.000000; -NODES[16628](IS_STRUCTURE,0) = 1.000000; -NODES[16630](IS_STRUCTURE,0) = 1.000000; -NODES[16631](IS_STRUCTURE,0) = 1.000000; -NODES[16632](IS_STRUCTURE,0) = 1.000000; -NODES[16639](IS_STRUCTURE,0) = 1.000000; -NODES[16645](IS_STRUCTURE,0) = 1.000000; -NODES[16647](IS_STRUCTURE,0) = 1.000000; -NODES[16651](IS_STRUCTURE,0) = 1.000000; -NODES[16653](IS_STRUCTURE,0) = 1.000000; -NODES[16662](IS_STRUCTURE,0) = 1.000000; -NODES[16663](IS_STRUCTURE,0) = 1.000000; -NODES[16665](IS_STRUCTURE,0) = 1.000000; -NODES[16679](IS_STRUCTURE,0) = 1.000000; -NODES[16681](IS_STRUCTURE,0) = 1.000000; -NODES[16682](IS_STRUCTURE,0) = 1.000000; -NODES[16688](IS_STRUCTURE,0) = 1.000000; -NODES[16701](IS_STRUCTURE,0) = 1.000000; -NODES[16711](IS_STRUCTURE,0) = 1.000000; -NODES[16716](IS_STRUCTURE,0) = 1.000000; -NODES[16721](IS_STRUCTURE,0) = 1.000000; -NODES[16730](IS_STRUCTURE,0) = 1.000000; -NODES[16733](IS_STRUCTURE,0) = 1.000000; -NODES[16736](IS_STRUCTURE,0) = 1.000000; -NODES[16737](IS_STRUCTURE,0) = 1.000000; -NODES[16742](IS_STRUCTURE,0) = 1.000000; -NODES[16749](IS_STRUCTURE,0) = 1.000000; -NODES[16754](IS_STRUCTURE,0) = 1.000000; -NODES[16762](IS_STRUCTURE,0) = 1.000000; -NODES[16765](IS_STRUCTURE,0) = 1.000000; -NODES[16766](IS_STRUCTURE,0) = 1.000000; -NODES[16774](IS_STRUCTURE,0) = 1.000000; -NODES[16775](IS_STRUCTURE,0) = 1.000000; -NODES[16791](IS_STRUCTURE,0) = 1.000000; -NODES[16797](IS_STRUCTURE,0) = 1.000000; -NODES[16813](IS_STRUCTURE,0) = 1.000000; -NODES[16821](IS_STRUCTURE,0) = 1.000000; -NODES[16823](IS_STRUCTURE,0) = 1.000000; -NODES[16824](IS_STRUCTURE,0) = 1.000000; -NODES[16828](IS_STRUCTURE,0) = 1.000000; -NODES[16829](IS_STRUCTURE,0) = 1.000000; -NODES[16837](IS_STRUCTURE,0) = 1.000000; -NODES[16841](IS_STRUCTURE,0) = 1.000000; -NODES[16844](IS_STRUCTURE,0) = 1.000000; -NODES[16847](IS_STRUCTURE,0) = 1.000000; -NODES[16850](IS_STRUCTURE,0) = 1.000000; -NODES[16851](IS_STRUCTURE,0) = 1.000000; -NODES[16858](IS_STRUCTURE,0) = 1.000000; -NODES[16867](IS_STRUCTURE,0) = 1.000000; -NODES[16874](IS_STRUCTURE,0) = 1.000000; -NODES[16877](IS_STRUCTURE,0) = 1.000000; -NODES[16878](IS_STRUCTURE,0) = 1.000000; -NODES[16879](IS_STRUCTURE,0) = 1.000000; -NODES[16881](IS_STRUCTURE,0) = 1.000000; -NODES[16884](IS_STRUCTURE,0) = 1.000000; -NODES[16887](IS_STRUCTURE,0) = 1.000000; -NODES[16899](IS_STRUCTURE,0) = 1.000000; -NODES[16906](IS_STRUCTURE,0) = 1.000000; -NODES[16907](IS_STRUCTURE,0) = 1.000000; -NODES[16908](IS_STRUCTURE,0) = 1.000000; -NODES[16939](IS_STRUCTURE,0) = 1.000000; -NODES[16940](IS_STRUCTURE,0) = 1.000000; -NODES[16952](IS_STRUCTURE,0) = 1.000000; -NODES[16953](IS_STRUCTURE,0) = 1.000000; -NODES[16955](IS_STRUCTURE,0) = 1.000000; -NODES[16962](IS_STRUCTURE,0) = 1.000000; -NODES[16966](IS_STRUCTURE,0) = 1.000000; -NODES[16970](IS_STRUCTURE,0) = 1.000000; -NODES[16974](IS_STRUCTURE,0) = 1.000000; -NODES[16986](IS_STRUCTURE,0) = 1.000000; -NODES[16990](IS_STRUCTURE,0) = 1.000000; -NODES[16993](IS_STRUCTURE,0) = 1.000000; -NODES[16995](IS_STRUCTURE,0) = 1.000000; -NODES[16996](IS_STRUCTURE,0) = 1.000000; -NODES[16997](IS_STRUCTURE,0) = 1.000000; -NODES[17000](IS_STRUCTURE,0) = 1.000000; -NODES[17009](IS_STRUCTURE,0) = 1.000000; -NODES[17010](IS_STRUCTURE,0) = 1.000000; -NODES[17015](IS_STRUCTURE,0) = 1.000000; -NODES[17016](IS_STRUCTURE,0) = 1.000000; -NODES[17029](IS_STRUCTURE,0) = 1.000000; -NODES[17030](IS_STRUCTURE,0) = 1.000000; -NODES[17034](IS_STRUCTURE,0) = 1.000000; -NODES[17039](IS_STRUCTURE,0) = 1.000000; -NODES[17042](IS_STRUCTURE,0) = 1.000000; -NODES[17043](IS_STRUCTURE,0) = 1.000000; -NODES[17047](IS_STRUCTURE,0) = 1.000000; -NODES[17055](IS_STRUCTURE,0) = 1.000000; -NODES[17062](IS_STRUCTURE,0) = 1.000000; -NODES[17064](IS_STRUCTURE,0) = 1.000000; -NODES[17072](IS_STRUCTURE,0) = 1.000000; -NODES[17077](IS_STRUCTURE,0) = 1.000000; -NODES[17081](IS_STRUCTURE,0) = 1.000000; -NODES[17092](IS_STRUCTURE,0) = 1.000000; -NODES[17093](IS_STRUCTURE,0) = 1.000000; -NODES[17104](IS_STRUCTURE,0) = 1.000000; -NODES[17106](IS_STRUCTURE,0) = 1.000000; -NODES[17110](IS_STRUCTURE,0) = 1.000000; -NODES[17111](IS_STRUCTURE,0) = 1.000000; -NODES[17112](IS_STRUCTURE,0) = 1.000000; -NODES[17115](IS_STRUCTURE,0) = 1.000000; -NODES[17124](IS_STRUCTURE,0) = 1.000000; -NODES[17125](IS_STRUCTURE,0) = 1.000000; -NODES[17133](IS_STRUCTURE,0) = 1.000000; -NODES[17142](IS_STRUCTURE,0) = 1.000000; -NODES[17145](IS_STRUCTURE,0) = 1.000000; -NODES[17152](IS_STRUCTURE,0) = 1.000000; -NODES[17153](IS_STRUCTURE,0) = 1.000000; -NODES[17158](IS_STRUCTURE,0) = 1.000000; -NODES[17161](IS_STRUCTURE,0) = 1.000000; -NODES[17167](IS_STRUCTURE,0) = 1.000000; -NODES[17169](IS_STRUCTURE,0) = 1.000000; -NODES[17190](IS_STRUCTURE,0) = 1.000000; -NODES[17191](IS_STRUCTURE,0) = 1.000000; -NODES[17193](IS_STRUCTURE,0) = 1.000000; -NODES[17194](IS_STRUCTURE,0) = 1.000000; -NODES[17196](IS_STRUCTURE,0) = 1.000000; -NODES[17197](IS_STRUCTURE,0) = 1.000000; -NODES[17200](IS_STRUCTURE,0) = 1.000000; -NODES[17202](IS_STRUCTURE,0) = 1.000000; -NODES[17209](IS_STRUCTURE,0) = 1.000000; -NODES[17211](IS_STRUCTURE,0) = 1.000000; -NODES[17233](IS_STRUCTURE,0) = 1.000000; -NODES[17235](IS_STRUCTURE,0) = 1.000000; -NODES[17238](IS_STRUCTURE,0) = 1.000000; -NODES[17240](IS_STRUCTURE,0) = 1.000000; -NODES[17245](IS_STRUCTURE,0) = 1.000000; -NODES[17262](IS_STRUCTURE,0) = 1.000000; -NODES[17266](IS_STRUCTURE,0) = 1.000000; -NODES[17270](IS_STRUCTURE,0) = 1.000000; -NODES[17272](IS_STRUCTURE,0) = 1.000000; -NODES[17276](IS_STRUCTURE,0) = 1.000000; -NODES[17278](IS_STRUCTURE,0) = 1.000000; -NODES[17279](IS_STRUCTURE,0) = 1.000000; -NODES[17284](IS_STRUCTURE,0) = 1.000000; -NODES[17287](IS_STRUCTURE,0) = 1.000000; -NODES[17295](IS_STRUCTURE,0) = 1.000000; -NODES[17299](IS_STRUCTURE,0) = 1.000000; -NODES[17300](IS_STRUCTURE,0) = 1.000000; -NODES[17302](IS_STRUCTURE,0) = 1.000000; -NODES[17327](IS_STRUCTURE,0) = 1.000000; -NODES[17330](IS_STRUCTURE,0) = 1.000000; -NODES[17347](IS_STRUCTURE,0) = 1.000000; -NODES[17357](IS_STRUCTURE,0) = 1.000000; -NODES[17359](IS_STRUCTURE,0) = 1.000000; -NODES[17361](IS_STRUCTURE,0) = 1.000000; -NODES[17365](IS_STRUCTURE,0) = 1.000000; -NODES[17366](IS_STRUCTURE,0) = 1.000000; -NODES[17368](IS_STRUCTURE,0) = 1.000000; -NODES[17370](IS_STRUCTURE,0) = 1.000000; -NODES[17371](IS_STRUCTURE,0) = 1.000000; -NODES[17376](IS_STRUCTURE,0) = 1.000000; -NODES[17382](IS_STRUCTURE,0) = 1.000000; -NODES[17386](IS_STRUCTURE,0) = 1.000000; -NODES[17390](IS_STRUCTURE,0) = 1.000000; -NODES[17392](IS_STRUCTURE,0) = 1.000000; -NODES[17395](IS_STRUCTURE,0) = 1.000000; -NODES[17400](IS_STRUCTURE,0) = 1.000000; -NODES[17403](IS_STRUCTURE,0) = 1.000000; -NODES[17404](IS_STRUCTURE,0) = 1.000000; -NODES[17411](IS_STRUCTURE,0) = 1.000000; -NODES[17413](IS_STRUCTURE,0) = 1.000000; -NODES[17418](IS_STRUCTURE,0) = 1.000000; -NODES[17422](IS_STRUCTURE,0) = 1.000000; -NODES[17427](IS_STRUCTURE,0) = 1.000000; -NODES[17436](IS_STRUCTURE,0) = 1.000000; -NODES[17440](IS_STRUCTURE,0) = 1.000000; -NODES[17442](IS_STRUCTURE,0) = 1.000000; -NODES[17453](IS_STRUCTURE,0) = 1.000000; -NODES[17455](IS_STRUCTURE,0) = 1.000000; -NODES[17459](IS_STRUCTURE,0) = 1.000000; -NODES[17465](IS_STRUCTURE,0) = 1.000000; -NODES[17466](IS_STRUCTURE,0) = 1.000000; -NODES[17472](IS_STRUCTURE,0) = 1.000000; -NODES[17479](IS_STRUCTURE,0) = 1.000000; -NODES[17482](IS_STRUCTURE,0) = 1.000000; -NODES[17486](IS_STRUCTURE,0) = 1.000000; -NODES[17487](IS_STRUCTURE,0) = 1.000000; -NODES[17496](IS_STRUCTURE,0) = 1.000000; -NODES[17498](IS_STRUCTURE,0) = 1.000000; -NODES[17502](IS_STRUCTURE,0) = 1.000000; -NODES[17508](IS_STRUCTURE,0) = 1.000000; -NODES[17516](IS_STRUCTURE,0) = 1.000000; -NODES[17518](IS_STRUCTURE,0) = 1.000000; -NODES[17519](IS_STRUCTURE,0) = 1.000000; -NODES[17522](IS_STRUCTURE,0) = 1.000000; -NODES[17525](IS_STRUCTURE,0) = 1.000000; -NODES[17526](IS_STRUCTURE,0) = 1.000000; -NODES[17531](IS_STRUCTURE,0) = 1.000000; -NODES[17538](IS_STRUCTURE,0) = 1.000000; -NODES[17541](IS_STRUCTURE,0) = 1.000000; -NODES[17559](IS_STRUCTURE,0) = 1.000000; -NODES[17561](IS_STRUCTURE,0) = 1.000000; -NODES[17562](IS_STRUCTURE,0) = 1.000000; -NODES[17566](IS_STRUCTURE,0) = 1.000000; -NODES[17567](IS_STRUCTURE,0) = 1.000000; -NODES[17577](IS_STRUCTURE,0) = 1.000000; -NODES[17579](IS_STRUCTURE,0) = 1.000000; -NODES[17583](IS_STRUCTURE,0) = 1.000000; -NODES[17584](IS_STRUCTURE,0) = 1.000000; -NODES[17585](IS_STRUCTURE,0) = 1.000000; -NODES[17606](IS_STRUCTURE,0) = 1.000000; -NODES[17611](IS_STRUCTURE,0) = 1.000000; -NODES[17617](IS_STRUCTURE,0) = 1.000000; -NODES[17621](IS_STRUCTURE,0) = 1.000000; -NODES[17628](IS_STRUCTURE,0) = 1.000000; -NODES[17630](IS_STRUCTURE,0) = 1.000000; -NODES[17632](IS_STRUCTURE,0) = 1.000000; -NODES[17639](IS_STRUCTURE,0) = 1.000000; -NODES[17642](IS_STRUCTURE,0) = 1.000000; -NODES[17651](IS_STRUCTURE,0) = 1.000000; -NODES[17654](IS_STRUCTURE,0) = 1.000000; -NODES[17655](IS_STRUCTURE,0) = 1.000000; -NODES[17661](IS_STRUCTURE,0) = 1.000000; -NODES[17665](IS_STRUCTURE,0) = 1.000000; -NODES[17668](IS_STRUCTURE,0) = 1.000000; -NODES[17669](IS_STRUCTURE,0) = 1.000000; -NODES[17675](IS_STRUCTURE,0) = 1.000000; -NODES[17680](IS_STRUCTURE,0) = 1.000000; -NODES[17681](IS_STRUCTURE,0) = 1.000000; -NODES[17684](IS_STRUCTURE,0) = 1.000000; -NODES[17685](IS_STRUCTURE,0) = 1.000000; -NODES[17686](IS_STRUCTURE,0) = 1.000000; -NODES[17690](IS_STRUCTURE,0) = 1.000000; -NODES[17695](IS_STRUCTURE,0) = 1.000000; -NODES[17696](IS_STRUCTURE,0) = 1.000000; -NODES[17698](IS_STRUCTURE,0) = 1.000000; -NODES[17713](IS_STRUCTURE,0) = 1.000000; -NODES[17717](IS_STRUCTURE,0) = 1.000000; -NODES[17718](IS_STRUCTURE,0) = 1.000000; -NODES[17723](IS_STRUCTURE,0) = 1.000000; -NODES[17726](IS_STRUCTURE,0) = 1.000000; -NODES[17729](IS_STRUCTURE,0) = 1.000000; -NODES[17735](IS_STRUCTURE,0) = 1.000000; -NODES[17736](IS_STRUCTURE,0) = 1.000000; -NODES[17742](IS_STRUCTURE,0) = 1.000000; -NODES[17745](IS_STRUCTURE,0) = 1.000000; -NODES[17757](IS_STRUCTURE,0) = 1.000000; -NODES[17761](IS_STRUCTURE,0) = 1.000000; -NODES[17762](IS_STRUCTURE,0) = 1.000000; -NODES[17763](IS_STRUCTURE,0) = 1.000000; -NODES[17765](IS_STRUCTURE,0) = 1.000000; -NODES[17766](IS_STRUCTURE,0) = 1.000000; -NODES[17771](IS_STRUCTURE,0) = 1.000000; -NODES[17774](IS_STRUCTURE,0) = 1.000000; -NODES[17776](IS_STRUCTURE,0) = 1.000000; -NODES[17781](IS_STRUCTURE,0) = 1.000000; -NODES[17797](IS_STRUCTURE,0) = 1.000000; -NODES[17807](IS_STRUCTURE,0) = 1.000000; -NODES[17816](IS_STRUCTURE,0) = 1.000000; -NODES[17817](IS_STRUCTURE,0) = 1.000000; -NODES[17819](IS_STRUCTURE,0) = 1.000000; -NODES[17820](IS_STRUCTURE,0) = 1.000000; -NODES[17829](IS_STRUCTURE,0) = 1.000000; -NODES[17831](IS_STRUCTURE,0) = 1.000000; -NODES[17837](IS_STRUCTURE,0) = 1.000000; -NODES[17846](IS_STRUCTURE,0) = 1.000000; -NODES[17847](IS_STRUCTURE,0) = 1.000000; -NODES[17849](IS_STRUCTURE,0) = 1.000000; -NODES[17861](IS_STRUCTURE,0) = 1.000000; -NODES[17862](IS_STRUCTURE,0) = 1.000000; -NODES[17864](IS_STRUCTURE,0) = 1.000000; -NODES[17866](IS_STRUCTURE,0) = 1.000000; -NODES[17869](IS_STRUCTURE,0) = 1.000000; -NODES[17870](IS_STRUCTURE,0) = 1.000000; -NODES[17871](IS_STRUCTURE,0) = 1.000000; -NODES[17878](IS_STRUCTURE,0) = 1.000000; -NODES[17880](IS_STRUCTURE,0) = 1.000000; -NODES[17881](IS_STRUCTURE,0) = 1.000000; -NODES[17883](IS_STRUCTURE,0) = 1.000000; -NODES[17886](IS_STRUCTURE,0) = 1.000000; -NODES[17888](IS_STRUCTURE,0) = 1.000000; -NODES[17893](IS_STRUCTURE,0) = 1.000000; -NODES[17898](IS_STRUCTURE,0) = 1.000000; -NODES[17906](IS_STRUCTURE,0) = 1.000000; -NODES[17907](IS_STRUCTURE,0) = 1.000000; -NODES[17910](IS_STRUCTURE,0) = 1.000000; -NODES[17914](IS_STRUCTURE,0) = 1.000000; -NODES[17915](IS_STRUCTURE,0) = 1.000000; -NODES[17916](IS_STRUCTURE,0) = 1.000000; -NODES[17918](IS_STRUCTURE,0) = 1.000000; -NODES[17923](IS_STRUCTURE,0) = 1.000000; -NODES[17926](IS_STRUCTURE,0) = 1.000000; -NODES[17927](IS_STRUCTURE,0) = 1.000000; -NODES[17928](IS_STRUCTURE,0) = 1.000000; -NODES[17937](IS_STRUCTURE,0) = 1.000000; -NODES[17941](IS_STRUCTURE,0) = 1.000000; -NODES[17942](IS_STRUCTURE,0) = 1.000000; -NODES[17953](IS_STRUCTURE,0) = 1.000000; -NODES[17954](IS_STRUCTURE,0) = 1.000000; -NODES[17962](IS_STRUCTURE,0) = 1.000000; -NODES[17968](IS_STRUCTURE,0) = 1.000000; -NODES[17973](IS_STRUCTURE,0) = 1.000000; -NODES[17976](IS_STRUCTURE,0) = 1.000000; -NODES[17984](IS_STRUCTURE,0) = 1.000000; -NODES[17985](IS_STRUCTURE,0) = 1.000000; -NODES[17988](IS_STRUCTURE,0) = 1.000000; -NODES[17989](IS_STRUCTURE,0) = 1.000000; -NODES[17990](IS_STRUCTURE,0) = 1.000000; -NODES[17991](IS_STRUCTURE,0) = 1.000000; -NODES[17997](IS_STRUCTURE,0) = 1.000000; -NODES[18000](IS_STRUCTURE,0) = 1.000000; -NODES[18002](IS_STRUCTURE,0) = 1.000000; -NODES[18006](IS_STRUCTURE,0) = 1.000000; -NODES[18027](IS_STRUCTURE,0) = 1.000000; -NODES[18028](IS_STRUCTURE,0) = 1.000000; -NODES[18030](IS_STRUCTURE,0) = 1.000000; -NODES[18032](IS_STRUCTURE,0) = 1.000000; -NODES[18033](IS_STRUCTURE,0) = 1.000000; -NODES[18040](IS_STRUCTURE,0) = 1.000000; -NODES[18043](IS_STRUCTURE,0) = 1.000000; -NODES[18046](IS_STRUCTURE,0) = 1.000000; -NODES[18052](IS_STRUCTURE,0) = 1.000000; -NODES[18053](IS_STRUCTURE,0) = 1.000000; -NODES[18059](IS_STRUCTURE,0) = 1.000000; -NODES[18064](IS_STRUCTURE,0) = 1.000000; -NODES[18066](IS_STRUCTURE,0) = 1.000000; -NODES[18068](IS_STRUCTURE,0) = 1.000000; -NODES[18070](IS_STRUCTURE,0) = 1.000000; -NODES[18071](IS_STRUCTURE,0) = 1.000000; -NODES[18073](IS_STRUCTURE,0) = 1.000000; -NODES[18080](IS_STRUCTURE,0) = 1.000000; -NODES[18083](IS_STRUCTURE,0) = 1.000000; -NODES[18084](IS_STRUCTURE,0) = 1.000000; -NODES[18085](IS_STRUCTURE,0) = 1.000000; -NODES[18086](IS_STRUCTURE,0) = 1.000000; -NODES[18089](IS_STRUCTURE,0) = 1.000000; -NODES[18095](IS_STRUCTURE,0) = 1.000000; -NODES[18105](IS_STRUCTURE,0) = 1.000000; -NODES[18106](IS_STRUCTURE,0) = 1.000000; -NODES[18113](IS_STRUCTURE,0) = 1.000000; -NODES[18115](IS_STRUCTURE,0) = 1.000000; -NODES[18116](IS_STRUCTURE,0) = 1.000000; -NODES[18118](IS_STRUCTURE,0) = 1.000000; -NODES[18119](IS_STRUCTURE,0) = 1.000000; -NODES[18120](IS_STRUCTURE,0) = 1.000000; -NODES[18121](IS_STRUCTURE,0) = 1.000000; -NODES[18125](IS_STRUCTURE,0) = 1.000000; -NODES[18126](IS_STRUCTURE,0) = 1.000000; -NODES[18136](IS_STRUCTURE,0) = 1.000000; -NODES[18141](IS_STRUCTURE,0) = 1.000000; -NODES[18142](IS_STRUCTURE,0) = 1.000000; -NODES[18145](IS_STRUCTURE,0) = 1.000000; -NODES[18147](IS_STRUCTURE,0) = 1.000000; -NODES[18149](IS_STRUCTURE,0) = 1.000000; -NODES[18150](IS_STRUCTURE,0) = 1.000000; -NODES[18162](IS_STRUCTURE,0) = 1.000000; -NODES[18163](IS_STRUCTURE,0) = 1.000000; -NODES[18164](IS_STRUCTURE,0) = 1.000000; -NODES[18167](IS_STRUCTURE,0) = 1.000000; -NODES[18168](IS_STRUCTURE,0) = 1.000000; -NODES[18170](IS_STRUCTURE,0) = 1.000000; -NODES[18175](IS_STRUCTURE,0) = 1.000000; -NODES[18180](IS_STRUCTURE,0) = 1.000000; -NODES[18181](IS_STRUCTURE,0) = 1.000000; -NODES[18184](IS_STRUCTURE,0) = 1.000000; -NODES[18186](IS_STRUCTURE,0) = 1.000000; -NODES[18190](IS_STRUCTURE,0) = 1.000000; -NODES[18193](IS_STRUCTURE,0) = 1.000000; -NODES[18197](IS_STRUCTURE,0) = 1.000000; -NODES[18199](IS_STRUCTURE,0) = 1.000000; -NODES[18203](IS_STRUCTURE,0) = 1.000000; -NODES[18209](IS_STRUCTURE,0) = 1.000000; -NODES[18214](IS_STRUCTURE,0) = 1.000000; -NODES[18217](IS_STRUCTURE,0) = 1.000000; -NODES[18218](IS_STRUCTURE,0) = 1.000000; -NODES[18221](IS_STRUCTURE,0) = 1.000000; -NODES[18225](IS_STRUCTURE,0) = 1.000000; -NODES[18227](IS_STRUCTURE,0) = 1.000000; -NODES[18233](IS_STRUCTURE,0) = 1.000000; -NODES[18236](IS_STRUCTURE,0) = 1.000000; -NODES[18242](IS_STRUCTURE,0) = 1.000000; -NODES[18245](IS_STRUCTURE,0) = 1.000000; -NODES[18247](IS_STRUCTURE,0) = 1.000000; -NODES[18251](IS_STRUCTURE,0) = 1.000000; -NODES[18255](IS_STRUCTURE,0) = 1.000000; -NODES[18256](IS_STRUCTURE,0) = 1.000000; -NODES[18259](IS_STRUCTURE,0) = 1.000000; -NODES[18260](IS_STRUCTURE,0) = 1.000000; -NODES[18261](IS_STRUCTURE,0) = 1.000000; -NODES[18265](IS_STRUCTURE,0) = 1.000000; -NODES[18266](IS_STRUCTURE,0) = 1.000000; -NODES[18272](IS_STRUCTURE,0) = 1.000000; -NODES[18273](IS_STRUCTURE,0) = 1.000000; -NODES[18274](IS_STRUCTURE,0) = 1.000000; -NODES[18284](IS_STRUCTURE,0) = 1.000000; -NODES[18285](IS_STRUCTURE,0) = 1.000000; -NODES[18286](IS_STRUCTURE,0) = 1.000000; -NODES[18291](IS_STRUCTURE,0) = 1.000000; -NODES[18300](IS_STRUCTURE,0) = 1.000000; -NODES[18301](IS_STRUCTURE,0) = 1.000000; -NODES[18303](IS_STRUCTURE,0) = 1.000000; -NODES[18304](IS_STRUCTURE,0) = 1.000000; -NODES[18306](IS_STRUCTURE,0) = 1.000000; -NODES[18312](IS_STRUCTURE,0) = 1.000000; -NODES[18316](IS_STRUCTURE,0) = 1.000000; -NODES[18317](IS_STRUCTURE,0) = 1.000000; -NODES[18322](IS_STRUCTURE,0) = 1.000000; -NODES[18323](IS_STRUCTURE,0) = 1.000000; -NODES[18325](IS_STRUCTURE,0) = 1.000000; -NODES[18331](IS_STRUCTURE,0) = 1.000000; -NODES[18337](IS_STRUCTURE,0) = 1.000000; -NODES[18338](IS_STRUCTURE,0) = 1.000000; -NODES[18339](IS_STRUCTURE,0) = 1.000000; -NODES[18340](IS_STRUCTURE,0) = 1.000000; -NODES[18341](IS_STRUCTURE,0) = 1.000000; -NODES[18342](IS_STRUCTURE,0) = 1.000000; -NODES[18343](IS_STRUCTURE,0) = 1.000000; -NODES[18351](IS_STRUCTURE,0) = 1.000000; -NODES[18352](IS_STRUCTURE,0) = 1.000000; -NODES[18353](IS_STRUCTURE,0) = 1.000000; -NODES[18356](IS_STRUCTURE,0) = 1.000000; -NODES[18358](IS_STRUCTURE,0) = 1.000000; -NODES[18359](IS_STRUCTURE,0) = 1.000000; -NODES[18360](IS_STRUCTURE,0) = 1.000000; -NODES[18361](IS_STRUCTURE,0) = 1.000000; -NODES[18365](IS_STRUCTURE,0) = 1.000000; -NODES[18367](IS_STRUCTURE,0) = 1.000000; -NODES[18369](IS_STRUCTURE,0) = 1.000000; -NODES[18372](IS_STRUCTURE,0) = 1.000000; -NODES[18373](IS_STRUCTURE,0) = 1.000000; -NODES[18379](IS_STRUCTURE,0) = 1.000000; -NODES[18381](IS_STRUCTURE,0) = 1.000000; -NODES[18382](IS_STRUCTURE,0) = 1.000000; -NODES[18384](IS_STRUCTURE,0) = 1.000000; -NODES[18386](IS_STRUCTURE,0) = 1.000000; -NODES[18390](IS_STRUCTURE,0) = 1.000000; -NODES[18394](IS_STRUCTURE,0) = 1.000000; -NODES[18400](IS_STRUCTURE,0) = 1.000000; -NODES[18401](IS_STRUCTURE,0) = 1.000000; -NODES[18402](IS_STRUCTURE,0) = 1.000000; -NODES[18403](IS_STRUCTURE,0) = 1.000000; -NODES[18404](IS_STRUCTURE,0) = 1.000000; -NODES[18406](IS_STRUCTURE,0) = 1.000000; -NODES[18408](IS_STRUCTURE,0) = 1.000000; -NODES[18409](IS_STRUCTURE,0) = 1.000000; -NODES[18410](IS_STRUCTURE,0) = 1.000000; -NODES[18415](IS_STRUCTURE,0) = 1.000000; -NODES[18422](IS_STRUCTURE,0) = 1.000000; -NODES[18424](IS_STRUCTURE,0) = 1.000000; -NODES[18425](IS_STRUCTURE,0) = 1.000000; -NODES[18428](IS_STRUCTURE,0) = 1.000000; -NODES[18433](IS_STRUCTURE,0) = 1.000000; -NODES[18435](IS_STRUCTURE,0) = 1.000000; -NODES[18437](IS_STRUCTURE,0) = 1.000000; -NODES[18439](IS_STRUCTURE,0) = 1.000000; -NODES[18441](IS_STRUCTURE,0) = 1.000000; -NODES[18443](IS_STRUCTURE,0) = 1.000000; -NODES[18446](IS_STRUCTURE,0) = 1.000000; -NODES[18448](IS_STRUCTURE,0) = 1.000000; -NODES[18449](IS_STRUCTURE,0) = 1.000000; -NODES[18453](IS_STRUCTURE,0) = 1.000000; -NODES[18455](IS_STRUCTURE,0) = 1.000000; -NODES[18456](IS_STRUCTURE,0) = 1.000000; -NODES[18457](IS_STRUCTURE,0) = 1.000000; -NODES[18461](IS_STRUCTURE,0) = 1.000000; -NODES[18465](IS_STRUCTURE,0) = 1.000000; -NODES[18466](IS_STRUCTURE,0) = 1.000000; -NODES[18467](IS_STRUCTURE,0) = 1.000000; -NODES[18468](IS_STRUCTURE,0) = 1.000000; -NODES[18469](IS_STRUCTURE,0) = 1.000000; -NODES[18471](IS_STRUCTURE,0) = 1.000000; -NODES[18476](IS_STRUCTURE,0) = 1.000000; -NODES[18478](IS_STRUCTURE,0) = 1.000000; -NODES[18479](IS_STRUCTURE,0) = 1.000000; -NODES[18481](IS_STRUCTURE,0) = 1.000000; -NODES[18482](IS_STRUCTURE,0) = 1.000000; -NODES[18483](IS_STRUCTURE,0) = 1.000000; -NODES[18490](IS_STRUCTURE,0) = 1.000000; -NODES[18492](IS_STRUCTURE,0) = 1.000000; -NODES[18494](IS_STRUCTURE,0) = 1.000000; -NODES[18497](IS_STRUCTURE,0) = 1.000000; -NODES[18498](IS_STRUCTURE,0) = 1.000000; -NODES[18499](IS_STRUCTURE,0) = 1.000000; -NODES[18500](IS_STRUCTURE,0) = 1.000000; -NODES[18503](IS_STRUCTURE,0) = 1.000000; -NODES[18505](IS_STRUCTURE,0) = 1.000000; -NODES[18506](IS_STRUCTURE,0) = 1.000000; -NODES[18508](IS_STRUCTURE,0) = 1.000000; -NODES[18509](IS_STRUCTURE,0) = 1.000000; -NODES[18512](IS_STRUCTURE,0) = 1.000000; -NODES[18514](IS_STRUCTURE,0) = 1.000000; -NODES[18515](IS_STRUCTURE,0) = 1.000000; -NODES[18516](IS_STRUCTURE,0) = 1.000000; -NODES[18517](IS_STRUCTURE,0) = 1.000000; -NODES[18519](IS_STRUCTURE,0) = 1.000000; -NODES[18521](IS_STRUCTURE,0) = 1.000000; -NODES[18523](IS_STRUCTURE,0) = 1.000000; -NODES[18527](IS_STRUCTURE,0) = 1.000000; -NODES[18530](IS_STRUCTURE,0) = 1.000000; -NODES[18531](IS_STRUCTURE,0) = 1.000000; -NODES[18533](IS_STRUCTURE,0) = 1.000000; -NODES[18536](IS_STRUCTURE,0) = 1.000000; -NODES[18538](IS_STRUCTURE,0) = 1.000000; -NODES[18539](IS_STRUCTURE,0) = 1.000000; -NODES[18540](IS_STRUCTURE,0) = 1.000000; -NODES[18541](IS_STRUCTURE,0) = 1.000000; -NODES[18542](IS_STRUCTURE,0) = 1.000000; -NODES[18543](IS_STRUCTURE,0) = 1.000000; -NODES[18544](IS_STRUCTURE,0) = 1.000000; -NODES[18545](IS_STRUCTURE,0) = 1.000000; -NODES[18546](IS_STRUCTURE,0) = 1.000000; -NODES[18554](IS_STRUCTURE,0) = 1.000000; -NODES[18556](IS_STRUCTURE,0) = 1.000000; -NODES[18557](IS_STRUCTURE,0) = 1.000000; -NODES[18558](IS_STRUCTURE,0) = 1.000000; -NODES[18559](IS_STRUCTURE,0) = 1.000000; -NODES[18560](IS_STRUCTURE,0) = 1.000000; -NODES[18562](IS_STRUCTURE,0) = 1.000000; -NODES[18563](IS_STRUCTURE,0) = 1.000000; -NODES[18564](IS_STRUCTURE,0) = 1.000000; -NODES[18568](IS_STRUCTURE,0) = 1.000000; -NODES[18569](IS_STRUCTURE,0) = 1.000000; -NODES[18570](IS_STRUCTURE,0) = 1.000000; -NODES[18573](IS_STRUCTURE,0) = 1.000000; -NODES[18575](IS_STRUCTURE,0) = 1.000000; -NODES[18576](IS_STRUCTURE,0) = 1.000000; -NODES[18577](IS_STRUCTURE,0) = 1.000000; -NODES[18579](IS_STRUCTURE,0) = 1.000000; -NODES[18580](IS_STRUCTURE,0) = 1.000000; -NODES[18581](IS_STRUCTURE,0) = 1.000000; -NODES[18582](IS_STRUCTURE,0) = 1.000000; -NODES[18585](IS_STRUCTURE,0) = 1.000000; -NODES[18589](IS_STRUCTURE,0) = 1.000000; -NODES[18590](IS_STRUCTURE,0) = 1.000000; -NODES[18591](IS_STRUCTURE,0) = 1.000000; -NODES[18592](IS_STRUCTURE,0) = 1.000000; -NODES[18593](IS_STRUCTURE,0) = 1.000000; -NODES[18594](IS_STRUCTURE,0) = 1.000000; -NODES[18595](IS_STRUCTURE,0) = 1.000000; -NODES[18597](IS_STRUCTURE,0) = 1.000000; -NODES[18601](IS_STRUCTURE,0) = 1.000000; -NODES[18604](IS_STRUCTURE,0) = 1.000000; -NODES[18605](IS_STRUCTURE,0) = 1.000000; -NODES[18609](IS_STRUCTURE,0) = 1.000000; -NODES[18610](IS_STRUCTURE,0) = 1.000000; -NODES[18611](IS_STRUCTURE,0) = 1.000000; -NODES[18612](IS_STRUCTURE,0) = 1.000000; -NODES[18613](IS_STRUCTURE,0) = 1.000000; -NODES[18616](IS_STRUCTURE,0) = 1.000000; -NODES[18618](IS_STRUCTURE,0) = 1.000000; -NODES[18619](IS_STRUCTURE,0) = 1.000000; -NODES[18621](IS_STRUCTURE,0) = 1.000000; -NODES[18622](IS_STRUCTURE,0) = 1.000000; -NODES[18623](IS_STRUCTURE,0) = 1.000000; -NODES[18624](IS_STRUCTURE,0) = 1.000000; -NODES[18626](IS_STRUCTURE,0) = 1.000000; -NODES[18629](IS_STRUCTURE,0) = 1.000000; -NODES[18630](IS_STRUCTURE,0) = 1.000000; -NODES[18632](IS_STRUCTURE,0) = 1.000000; -NODES[18633](IS_STRUCTURE,0) = 1.000000; -NODES[18634](IS_STRUCTURE,0) = 1.000000; -NODES[18635](IS_STRUCTURE,0) = 1.000000; -NODES[18636](IS_STRUCTURE,0) = 1.000000; -NODES[18639](IS_STRUCTURE,0) = 1.000000; -NODES[18641](IS_STRUCTURE,0) = 1.000000; -NODES[18642](IS_STRUCTURE,0) = 1.000000; -NODES[18644](IS_STRUCTURE,0) = 1.000000; -NODES[18645](IS_STRUCTURE,0) = 1.000000; -NODES[18646](IS_STRUCTURE,0) = 1.000000; -NODES[18647](IS_STRUCTURE,0) = 1.000000; -NODES[18654](IS_STRUCTURE,0) = 1.000000; -NODES[18657](IS_STRUCTURE,0) = 1.000000; -NODES[18658](IS_STRUCTURE,0) = 1.000000; -NODES[18659](IS_STRUCTURE,0) = 1.000000; -NODES[18660](IS_STRUCTURE,0) = 1.000000; -NODES[18661](IS_STRUCTURE,0) = 1.000000; -NODES[18662](IS_STRUCTURE,0) = 1.000000; -NODES[18663](IS_STRUCTURE,0) = 1.000000; -NODES[18664](IS_STRUCTURE,0) = 1.000000; -NODES[18666](IS_STRUCTURE,0) = 1.000000; -NODES[18667](IS_STRUCTURE,0) = 1.000000; -NODES[18668](IS_STRUCTURE,0) = 1.000000; -NODES[18669](IS_STRUCTURE,0) = 1.000000; -NODES[18672](IS_STRUCTURE,0) = 1.000000; -NODES[18673](IS_STRUCTURE,0) = 1.000000; -NODES[18674](IS_STRUCTURE,0) = 1.000000; -NODES[18676](IS_STRUCTURE,0) = 1.000000; -NODES[18677](IS_STRUCTURE,0) = 1.000000; -NODES[18680](IS_STRUCTURE,0) = 1.000000; -NODES[18681](IS_STRUCTURE,0) = 1.000000; -NODES[18682](IS_STRUCTURE,0) = 1.000000; -NODES[18683](IS_STRUCTURE,0) = 1.000000; -NODES[18684](IS_STRUCTURE,0) = 1.000000; -NODES[18686](IS_STRUCTURE,0) = 1.000000; -NODES[18687](IS_STRUCTURE,0) = 1.000000; -NODES[18688](IS_STRUCTURE,0) = 1.000000; -NODES[18689](IS_STRUCTURE,0) = 1.000000; -NODES[18690](IS_STRUCTURE,0) = 1.000000; -NODES[18692](IS_STRUCTURE,0) = 1.000000; -NODES[18693](IS_STRUCTURE,0) = 1.000000; -NODES[18694](IS_STRUCTURE,0) = 1.000000; -NODES[18695](IS_STRUCTURE,0) = 1.000000; -NODES[18696](IS_STRUCTURE,0) = 1.000000; -NODES[18697](IS_STRUCTURE,0) = 1.000000; -NODES[18698](IS_STRUCTURE,0) = 1.000000; -NODES[18699](IS_STRUCTURE,0) = 1.000000; -NODES[1](VELOCITY_X,0) = 0.000000; -NODES[1](VELOCITY_Y,0) = 0.000000; -NODES[1](VELOCITY_Z,0) = 0.000000; -NODES[2](VELOCITY_X,0) = 0.000000; -NODES[2](VELOCITY_Y,0) = 0.000000; -NODES[2](VELOCITY_Z,0) = 0.000000; -NODES[3](VELOCITY_X,0) = 0.000000; -NODES[3](VELOCITY_Y,0) = 0.000000; -NODES[3](VELOCITY_Z,0) = 0.000000; -NODES[4](VELOCITY_X,0) = 0.000000; -NODES[4](VELOCITY_Y,0) = 0.000000; -NODES[4](VELOCITY_Z,0) = 0.000000; -NODES[5](VELOCITY_X,0) = 0.000000; -NODES[5](VELOCITY_Y,0) = 0.000000; -NODES[5](VELOCITY_Z,0) = 0.000000; -NODES[6](VELOCITY_X,0) = 0.000000; -NODES[6](VELOCITY_Y,0) = 0.000000; -NODES[6](VELOCITY_Z,0) = 0.000000; -NODES[7](VELOCITY_X,0) = 0.000000; -NODES[7](VELOCITY_Y,0) = 0.000000; -NODES[7](VELOCITY_Z,0) = 0.000000; -NODES[8](VELOCITY_X,0) = 0.000000; -NODES[8](VELOCITY_Y,0) = 0.000000; -NODES[8](VELOCITY_Z,0) = 0.000000; -NODES[9](VELOCITY_X,0) = 0.000000; -NODES[9](VELOCITY_Y,0) = 0.000000; -NODES[9](VELOCITY_Z,0) = 0.000000; -NODES[10](VELOCITY_X,0) = 0.000000; -NODES[10](VELOCITY_Y,0) = 0.000000; -NODES[10](VELOCITY_Z,0) = 0.000000; -NODES[11](VELOCITY_X,0) = 0.000000; -NODES[11](VELOCITY_Y,0) = 0.000000; -NODES[11](VELOCITY_Z,0) = 0.000000; -NODES[12](VELOCITY_X,0) = 0.000000; -NODES[12](VELOCITY_Y,0) = 0.000000; -NODES[12](VELOCITY_Z,0) = 0.000000; -NODES[13](VELOCITY_X,0) = 0.000000; -NODES[13](VELOCITY_Y,0) = 0.000000; -NODES[13](VELOCITY_Z,0) = 0.000000; -NODES[14](VELOCITY_X,0) = 0.000000; -NODES[14](VELOCITY_Y,0) = 0.000000; -NODES[14](VELOCITY_Z,0) = 0.000000; -NODES[15](VELOCITY_X,0) = 0.000000; -NODES[15](VELOCITY_Y,0) = 0.000000; -NODES[15](VELOCITY_Z,0) = 0.000000; -NODES[16](VELOCITY_X,0) = 0.000000; -NODES[16](VELOCITY_Y,0) = 0.000000; -NODES[16](VELOCITY_Z,0) = 0.000000; -NODES[17](VELOCITY_X,0) = 0.000000; -NODES[17](VELOCITY_Y,0) = 0.000000; -NODES[17](VELOCITY_Z,0) = 0.000000; -NODES[18](VELOCITY_X,0) = 0.000000; -NODES[18](VELOCITY_Y,0) = 0.000000; -NODES[18](VELOCITY_Z,0) = 0.000000; -NODES[19](VELOCITY_X,0) = 0.000000; -NODES[19](VELOCITY_Y,0) = 0.000000; -NODES[19](VELOCITY_Z,0) = 0.000000; -NODES[20](VELOCITY_X,0) = 0.000000; -NODES[20](VELOCITY_Y,0) = 0.000000; -NODES[20](VELOCITY_Z,0) = 0.000000; -NODES[21](VELOCITY_X,0) = 0.000000; -NODES[21](VELOCITY_Y,0) = 0.000000; -NODES[21](VELOCITY_Z,0) = 0.000000; -NODES[22](VELOCITY_X,0) = 0.000000; -NODES[22](VELOCITY_Y,0) = 0.000000; -NODES[22](VELOCITY_Z,0) = 0.000000; -NODES[23](VELOCITY_X,0) = 0.000000; -NODES[23](VELOCITY_Y,0) = 0.000000; -NODES[23](VELOCITY_Z,0) = 0.000000; -NODES[24](VELOCITY_X,0) = 0.000000; -NODES[24](VELOCITY_Y,0) = 0.000000; -NODES[24](VELOCITY_Z,0) = 0.000000; -NODES[25](VELOCITY_X,0) = 0.000000; -NODES[25](VELOCITY_Y,0) = 0.000000; -NODES[25](VELOCITY_Z,0) = 0.000000; -NODES[26](VELOCITY_X,0) = 0.000000; -NODES[26](VELOCITY_Y,0) = 0.000000; -NODES[26](VELOCITY_Z,0) = 0.000000; -NODES[27](VELOCITY_X,0) = 0.000000; -NODES[27](VELOCITY_Y,0) = 0.000000; -NODES[27](VELOCITY_Z,0) = 0.000000; -NODES[28](VELOCITY_X,0) = 0.000000; -NODES[28](VELOCITY_Y,0) = 0.000000; -NODES[28](VELOCITY_Z,0) = 0.000000; -NODES[29](VELOCITY_X,0) = 0.000000; -NODES[29](VELOCITY_Y,0) = 0.000000; -NODES[29](VELOCITY_Z,0) = 0.000000; -NODES[30](VELOCITY_X,0) = 0.000000; -NODES[30](VELOCITY_Y,0) = 0.000000; -NODES[30](VELOCITY_Z,0) = 0.000000; -NODES[31](VELOCITY_X,0) = 0.000000; -NODES[31](VELOCITY_Y,0) = 0.000000; -NODES[31](VELOCITY_Z,0) = 0.000000; -NODES[32](VELOCITY_X,0) = 0.000000; -NODES[32](VELOCITY_Y,0) = 0.000000; -NODES[32](VELOCITY_Z,0) = 0.000000; -NODES[33](VELOCITY_X,0) = 0.000000; -NODES[33](VELOCITY_Y,0) = 0.000000; -NODES[33](VELOCITY_Z,0) = 0.000000; -NODES[34](VELOCITY_X,0) = 0.000000; -NODES[34](VELOCITY_Y,0) = 0.000000; -NODES[34](VELOCITY_Z,0) = 0.000000; -NODES[35](VELOCITY_X,0) = 0.000000; -NODES[35](VELOCITY_Y,0) = 0.000000; -NODES[35](VELOCITY_Z,0) = 0.000000; -NODES[36](VELOCITY_X,0) = 0.000000; -NODES[36](VELOCITY_Y,0) = 0.000000; -NODES[36](VELOCITY_Z,0) = 0.000000; -NODES[37](VELOCITY_X,0) = 0.000000; -NODES[37](VELOCITY_Y,0) = 0.000000; -NODES[37](VELOCITY_Z,0) = 0.000000; -NODES[38](VELOCITY_X,0) = 0.000000; -NODES[38](VELOCITY_Y,0) = 0.000000; -NODES[38](VELOCITY_Z,0) = 0.000000; -NODES[39](VELOCITY_X,0) = 0.000000; -NODES[39](VELOCITY_Y,0) = 0.000000; -NODES[39](VELOCITY_Z,0) = 0.000000; -NODES[40](VELOCITY_X,0) = 0.000000; -NODES[40](VELOCITY_Y,0) = 0.000000; -NODES[40](VELOCITY_Z,0) = 0.000000; -NODES[41](VELOCITY_X,0) = 0.000000; -NODES[41](VELOCITY_Y,0) = 0.000000; -NODES[41](VELOCITY_Z,0) = 0.000000; -NODES[42](VELOCITY_X,0) = 0.000000; -NODES[42](VELOCITY_Y,0) = 0.000000; -NODES[42](VELOCITY_Z,0) = 0.000000; -NODES[43](VELOCITY_X,0) = 0.000000; -NODES[43](VELOCITY_Y,0) = 0.000000; -NODES[43](VELOCITY_Z,0) = 0.000000; -NODES[44](VELOCITY_X,0) = 0.000000; -NODES[44](VELOCITY_Y,0) = 0.000000; -NODES[44](VELOCITY_Z,0) = 0.000000; -NODES[45](VELOCITY_X,0) = 0.000000; -NODES[45](VELOCITY_Y,0) = 0.000000; -NODES[45](VELOCITY_Z,0) = 0.000000; -NODES[46](VELOCITY_X,0) = 0.000000; -NODES[46](VELOCITY_Y,0) = 0.000000; -NODES[46](VELOCITY_Z,0) = 0.000000; -NODES[47](VELOCITY_X,0) = 0.000000; -NODES[47](VELOCITY_Y,0) = 0.000000; -NODES[47](VELOCITY_Z,0) = 0.000000; -NODES[48](VELOCITY_X,0) = 0.000000; -NODES[48](VELOCITY_Y,0) = 0.000000; -NODES[48](VELOCITY_Z,0) = 0.000000; -NODES[49](VELOCITY_X,0) = 0.000000; -NODES[49](VELOCITY_Y,0) = 0.000000; -NODES[49](VELOCITY_Z,0) = 0.000000; -NODES[50](VELOCITY_X,0) = 0.000000; -NODES[50](VELOCITY_Y,0) = 0.000000; -NODES[50](VELOCITY_Z,0) = 0.000000; -NODES[51](VELOCITY_X,0) = 0.000000; -NODES[51](VELOCITY_Y,0) = 0.000000; -NODES[51](VELOCITY_Z,0) = 0.000000; -NODES[52](VELOCITY_X,0) = 0.000000; -NODES[52](VELOCITY_Y,0) = 0.000000; -NODES[52](VELOCITY_Z,0) = 0.000000; -NODES[53](VELOCITY_X,0) = 0.000000; -NODES[53](VELOCITY_Y,0) = 0.000000; -NODES[53](VELOCITY_Z,0) = 0.000000; -NODES[54](VELOCITY_X,0) = 0.000000; -NODES[54](VELOCITY_Y,0) = 0.000000; -NODES[54](VELOCITY_Z,0) = 0.000000; -NODES[55](VELOCITY_X,0) = 0.000000; -NODES[55](VELOCITY_Y,0) = 0.000000; -NODES[55](VELOCITY_Z,0) = 0.000000; -NODES[56](VELOCITY_X,0) = 0.000000; -NODES[56](VELOCITY_Y,0) = 0.000000; -NODES[56](VELOCITY_Z,0) = 0.000000; -NODES[57](VELOCITY_X,0) = 0.000000; -NODES[57](VELOCITY_Y,0) = 0.000000; -NODES[57](VELOCITY_Z,0) = 0.000000; -NODES[58](VELOCITY_X,0) = 0.000000; -NODES[58](VELOCITY_Y,0) = 0.000000; -NODES[58](VELOCITY_Z,0) = 0.000000; -NODES[59](VELOCITY_X,0) = 0.000000; -NODES[59](VELOCITY_Y,0) = 0.000000; -NODES[59](VELOCITY_Z,0) = 0.000000; -NODES[60](VELOCITY_X,0) = 0.000000; -NODES[60](VELOCITY_Y,0) = 0.000000; -NODES[60](VELOCITY_Z,0) = 0.000000; -NODES[61](VELOCITY_X,0) = 0.000000; -NODES[61](VELOCITY_Y,0) = 0.000000; -NODES[61](VELOCITY_Z,0) = 0.000000; -NODES[62](VELOCITY_X,0) = 0.000000; -NODES[62](VELOCITY_Y,0) = 0.000000; -NODES[62](VELOCITY_Z,0) = 0.000000; -NODES[63](VELOCITY_X,0) = 0.000000; -NODES[63](VELOCITY_Y,0) = 0.000000; -NODES[63](VELOCITY_Z,0) = 0.000000; -NODES[64](VELOCITY_X,0) = 0.000000; -NODES[64](VELOCITY_Y,0) = 0.000000; -NODES[64](VELOCITY_Z,0) = 0.000000; -NODES[65](VELOCITY_X,0) = 0.000000; -NODES[65](VELOCITY_Y,0) = 0.000000; -NODES[65](VELOCITY_Z,0) = 0.000000; -NODES[66](VELOCITY_X,0) = 0.000000; -NODES[66](VELOCITY_Y,0) = 0.000000; -NODES[66](VELOCITY_Z,0) = 0.000000; -NODES[67](VELOCITY_X,0) = 0.000000; -NODES[67](VELOCITY_Y,0) = 0.000000; -NODES[67](VELOCITY_Z,0) = 0.000000; -NODES[68](VELOCITY_X,0) = 0.000000; -NODES[68](VELOCITY_Y,0) = 0.000000; -NODES[68](VELOCITY_Z,0) = 0.000000; -NODES[69](VELOCITY_X,0) = 0.000000; -NODES[69](VELOCITY_Y,0) = 0.000000; -NODES[69](VELOCITY_Z,0) = 0.000000; -NODES[70](VELOCITY_X,0) = 0.000000; -NODES[70](VELOCITY_Y,0) = 0.000000; -NODES[70](VELOCITY_Z,0) = 0.000000; -NODES[71](VELOCITY_X,0) = 0.000000; -NODES[71](VELOCITY_Y,0) = 0.000000; -NODES[71](VELOCITY_Z,0) = 0.000000; -NODES[72](VELOCITY_X,0) = 0.000000; -NODES[72](VELOCITY_Y,0) = 0.000000; -NODES[72](VELOCITY_Z,0) = 0.000000; -NODES[73](VELOCITY_X,0) = 0.000000; -NODES[73](VELOCITY_Y,0) = 0.000000; -NODES[73](VELOCITY_Z,0) = 0.000000; -NODES[74](VELOCITY_X,0) = 0.000000; -NODES[74](VELOCITY_Y,0) = 0.000000; -NODES[74](VELOCITY_Z,0) = 0.000000; -NODES[75](VELOCITY_X,0) = 0.000000; -NODES[75](VELOCITY_Y,0) = 0.000000; -NODES[75](VELOCITY_Z,0) = 0.000000; -NODES[76](VELOCITY_X,0) = 0.000000; -NODES[76](VELOCITY_Y,0) = 0.000000; -NODES[76](VELOCITY_Z,0) = 0.000000; -NODES[77](VELOCITY_X,0) = 0.000000; -NODES[77](VELOCITY_Y,0) = 0.000000; -NODES[77](VELOCITY_Z,0) = 0.000000; -NODES[78](VELOCITY_X,0) = 0.000000; -NODES[78](VELOCITY_Y,0) = 0.000000; -NODES[78](VELOCITY_Z,0) = 0.000000; -NODES[79](VELOCITY_X,0) = 0.000000; -NODES[79](VELOCITY_Y,0) = 0.000000; -NODES[79](VELOCITY_Z,0) = 0.000000; -NODES[80](VELOCITY_X,0) = 0.000000; -NODES[80](VELOCITY_Y,0) = 0.000000; -NODES[80](VELOCITY_Z,0) = 0.000000; -NODES[81](VELOCITY_X,0) = 0.000000; -NODES[81](VELOCITY_Y,0) = 0.000000; -NODES[81](VELOCITY_Z,0) = 0.000000; -NODES[82](VELOCITY_X,0) = 0.000000; -NODES[82](VELOCITY_Y,0) = 0.000000; -NODES[82](VELOCITY_Z,0) = 0.000000; -NODES[83](VELOCITY_X,0) = 0.000000; -NODES[83](VELOCITY_Y,0) = 0.000000; -NODES[83](VELOCITY_Z,0) = 0.000000; -NODES[84](VELOCITY_X,0) = 0.000000; -NODES[84](VELOCITY_Y,0) = 0.000000; -NODES[84](VELOCITY_Z,0) = 0.000000; -NODES[85](VELOCITY_X,0) = 0.000000; -NODES[85](VELOCITY_Y,0) = 0.000000; -NODES[85](VELOCITY_Z,0) = 0.000000; -NODES[86](VELOCITY_X,0) = 0.000000; -NODES[86](VELOCITY_Y,0) = 0.000000; -NODES[86](VELOCITY_Z,0) = 0.000000; -NODES[87](VELOCITY_X,0) = 0.000000; -NODES[87](VELOCITY_Y,0) = 0.000000; -NODES[87](VELOCITY_Z,0) = 0.000000; -NODES[88](VELOCITY_X,0) = 0.000000; -NODES[88](VELOCITY_Y,0) = 0.000000; -NODES[88](VELOCITY_Z,0) = 0.000000; -NODES[89](VELOCITY_X,0) = 0.000000; -NODES[89](VELOCITY_Y,0) = 0.000000; -NODES[89](VELOCITY_Z,0) = 0.000000; -NODES[90](VELOCITY_X,0) = 0.000000; -NODES[90](VELOCITY_Y,0) = 0.000000; -NODES[90](VELOCITY_Z,0) = 0.000000; -NODES[91](VELOCITY_X,0) = 0.000000; -NODES[91](VELOCITY_Y,0) = 0.000000; -NODES[91](VELOCITY_Z,0) = 0.000000; -NODES[92](VELOCITY_X,0) = 0.000000; -NODES[92](VELOCITY_Y,0) = 0.000000; -NODES[92](VELOCITY_Z,0) = 0.000000; -NODES[93](VELOCITY_X,0) = 0.000000; -NODES[93](VELOCITY_Y,0) = 0.000000; -NODES[93](VELOCITY_Z,0) = 0.000000; -NODES[94](VELOCITY_X,0) = 0.000000; -NODES[94](VELOCITY_Y,0) = 0.000000; -NODES[94](VELOCITY_Z,0) = 0.000000; -NODES[95](VELOCITY_X,0) = 0.000000; -NODES[95](VELOCITY_Y,0) = 0.000000; -NODES[95](VELOCITY_Z,0) = 0.000000; -NODES[96](VELOCITY_X,0) = 0.000000; -NODES[96](VELOCITY_Y,0) = 0.000000; -NODES[96](VELOCITY_Z,0) = 0.000000; -NODES[97](VELOCITY_X,0) = 0.000000; -NODES[97](VELOCITY_Y,0) = 0.000000; -NODES[97](VELOCITY_Z,0) = 0.000000; -NODES[98](VELOCITY_X,0) = 0.000000; -NODES[98](VELOCITY_Y,0) = 0.000000; -NODES[98](VELOCITY_Z,0) = 0.000000; -NODES[99](VELOCITY_X,0) = 0.000000; -NODES[99](VELOCITY_Y,0) = 0.000000; -NODES[99](VELOCITY_Z,0) = 0.000000; -NODES[100](VELOCITY_X,0) = 0.000000; -NODES[100](VELOCITY_Y,0) = 0.000000; -NODES[100](VELOCITY_Z,0) = 0.000000; -NODES[101](VELOCITY_X,0) = 0.000000; -NODES[101](VELOCITY_Y,0) = 0.000000; -NODES[101](VELOCITY_Z,0) = 0.000000; -NODES[102](VELOCITY_X,0) = 0.000000; -NODES[102](VELOCITY_Y,0) = 0.000000; -NODES[102](VELOCITY_Z,0) = 0.000000; -NODES[103](VELOCITY_X,0) = 0.000000; -NODES[103](VELOCITY_Y,0) = 0.000000; -NODES[103](VELOCITY_Z,0) = 0.000000; -NODES[104](VELOCITY_X,0) = 0.000000; -NODES[104](VELOCITY_Y,0) = 0.000000; -NODES[104](VELOCITY_Z,0) = 0.000000; -NODES[105](VELOCITY_X,0) = 0.000000; -NODES[105](VELOCITY_Y,0) = 0.000000; -NODES[105](VELOCITY_Z,0) = 0.000000; -NODES[106](VELOCITY_X,0) = 0.000000; -NODES[106](VELOCITY_Y,0) = 0.000000; -NODES[106](VELOCITY_Z,0) = 0.000000; -NODES[107](VELOCITY_X,0) = 0.000000; -NODES[107](VELOCITY_Y,0) = 0.000000; -NODES[107](VELOCITY_Z,0) = 0.000000; -NODES[108](VELOCITY_X,0) = 0.000000; -NODES[108](VELOCITY_Y,0) = 0.000000; -NODES[108](VELOCITY_Z,0) = 0.000000; -NODES[109](VELOCITY_X,0) = 0.000000; -NODES[109](VELOCITY_Y,0) = 0.000000; -NODES[109](VELOCITY_Z,0) = 0.000000; -NODES[110](VELOCITY_X,0) = 0.000000; -NODES[110](VELOCITY_Y,0) = 0.000000; -NODES[110](VELOCITY_Z,0) = 0.000000; -NODES[111](VELOCITY_X,0) = 0.000000; -NODES[111](VELOCITY_Y,0) = 0.000000; -NODES[111](VELOCITY_Z,0) = 0.000000; -NODES[112](VELOCITY_X,0) = 0.000000; -NODES[112](VELOCITY_Y,0) = 0.000000; -NODES[112](VELOCITY_Z,0) = 0.000000; -NODES[113](VELOCITY_X,0) = 0.000000; -NODES[113](VELOCITY_Y,0) = 0.000000; -NODES[113](VELOCITY_Z,0) = 0.000000; -NODES[114](VELOCITY_X,0) = 0.000000; -NODES[114](VELOCITY_Y,0) = 0.000000; -NODES[114](VELOCITY_Z,0) = 0.000000; -NODES[115](VELOCITY_X,0) = 0.000000; -NODES[115](VELOCITY_Y,0) = 0.000000; -NODES[115](VELOCITY_Z,0) = 0.000000; -NODES[116](VELOCITY_X,0) = 0.000000; -NODES[116](VELOCITY_Y,0) = 0.000000; -NODES[116](VELOCITY_Z,0) = 0.000000; -NODES[117](VELOCITY_X,0) = 0.000000; -NODES[117](VELOCITY_Y,0) = 0.000000; -NODES[117](VELOCITY_Z,0) = 0.000000; -NODES[118](VELOCITY_X,0) = 0.000000; -NODES[118](VELOCITY_Y,0) = 0.000000; -NODES[118](VELOCITY_Z,0) = 0.000000; -NODES[119](VELOCITY_X,0) = 0.000000; -NODES[119](VELOCITY_Y,0) = 0.000000; -NODES[119](VELOCITY_Z,0) = 0.000000; -NODES[120](VELOCITY_X,0) = 0.000000; -NODES[120](VELOCITY_Y,0) = 0.000000; -NODES[120](VELOCITY_Z,0) = 0.000000; -NODES[121](VELOCITY_X,0) = 0.000000; -NODES[121](VELOCITY_Y,0) = 0.000000; -NODES[121](VELOCITY_Z,0) = 0.000000; -NODES[122](VELOCITY_X,0) = 0.000000; -NODES[122](VELOCITY_Y,0) = 0.000000; -NODES[122](VELOCITY_Z,0) = 0.000000; -NODES[123](VELOCITY_X,0) = 0.000000; -NODES[123](VELOCITY_Y,0) = 0.000000; -NODES[123](VELOCITY_Z,0) = 0.000000; -NODES[124](VELOCITY_X,0) = 0.000000; -NODES[124](VELOCITY_Y,0) = 0.000000; -NODES[124](VELOCITY_Z,0) = 0.000000; -NODES[125](VELOCITY_X,0) = 0.000000; -NODES[125](VELOCITY_Y,0) = 0.000000; -NODES[125](VELOCITY_Z,0) = 0.000000; -NODES[126](VELOCITY_X,0) = 0.000000; -NODES[126](VELOCITY_Y,0) = 0.000000; -NODES[126](VELOCITY_Z,0) = 0.000000; -NODES[127](VELOCITY_X,0) = 0.000000; -NODES[127](VELOCITY_Y,0) = 0.000000; -NODES[127](VELOCITY_Z,0) = 0.000000; -NODES[128](VELOCITY_X,0) = 0.000000; -NODES[128](VELOCITY_Y,0) = 0.000000; -NODES[128](VELOCITY_Z,0) = 0.000000; -NODES[129](VELOCITY_X,0) = 0.000000; -NODES[129](VELOCITY_Y,0) = 0.000000; -NODES[129](VELOCITY_Z,0) = 0.000000; -NODES[130](VELOCITY_X,0) = 0.000000; -NODES[130](VELOCITY_Y,0) = 0.000000; -NODES[130](VELOCITY_Z,0) = 0.000000; -NODES[131](VELOCITY_X,0) = 0.000000; -NODES[131](VELOCITY_Y,0) = 0.000000; -NODES[131](VELOCITY_Z,0) = 0.000000; -NODES[132](VELOCITY_X,0) = 0.000000; -NODES[132](VELOCITY_Y,0) = 0.000000; -NODES[132](VELOCITY_Z,0) = 0.000000; -NODES[133](VELOCITY_X,0) = 0.000000; -NODES[133](VELOCITY_Y,0) = 0.000000; -NODES[133](VELOCITY_Z,0) = 0.000000; -NODES[134](VELOCITY_X,0) = 0.000000; -NODES[134](VELOCITY_Y,0) = 0.000000; -NODES[134](VELOCITY_Z,0) = 0.000000; -NODES[135](VELOCITY_X,0) = 0.000000; -NODES[135](VELOCITY_Y,0) = 0.000000; -NODES[135](VELOCITY_Z,0) = 0.000000; -NODES[136](VELOCITY_X,0) = 0.000000; -NODES[136](VELOCITY_Y,0) = 0.000000; -NODES[136](VELOCITY_Z,0) = 0.000000; -NODES[137](VELOCITY_X,0) = 0.000000; -NODES[137](VELOCITY_Y,0) = 0.000000; -NODES[137](VELOCITY_Z,0) = 0.000000; -NODES[138](VELOCITY_X,0) = 0.000000; -NODES[138](VELOCITY_Y,0) = 0.000000; -NODES[138](VELOCITY_Z,0) = 0.000000; -NODES[139](VELOCITY_X,0) = 0.000000; -NODES[139](VELOCITY_Y,0) = 0.000000; -NODES[139](VELOCITY_Z,0) = 0.000000; -NODES[140](VELOCITY_X,0) = 0.000000; -NODES[140](VELOCITY_Y,0) = 0.000000; -NODES[140](VELOCITY_Z,0) = 0.000000; -NODES[141](VELOCITY_X,0) = 0.000000; -NODES[141](VELOCITY_Y,0) = 0.000000; -NODES[141](VELOCITY_Z,0) = 0.000000; -NODES[142](VELOCITY_X,0) = 0.000000; -NODES[142](VELOCITY_Y,0) = 0.000000; -NODES[142](VELOCITY_Z,0) = 0.000000; -NODES[143](VELOCITY_X,0) = 0.000000; -NODES[143](VELOCITY_Y,0) = 0.000000; -NODES[143](VELOCITY_Z,0) = 0.000000; -NODES[144](VELOCITY_X,0) = 0.000000; -NODES[144](VELOCITY_Y,0) = 0.000000; -NODES[144](VELOCITY_Z,0) = 0.000000; -NODES[145](VELOCITY_X,0) = 0.000000; -NODES[145](VELOCITY_Y,0) = 0.000000; -NODES[145](VELOCITY_Z,0) = 0.000000; -NODES[146](VELOCITY_X,0) = 0.000000; -NODES[146](VELOCITY_Y,0) = 0.000000; -NODES[146](VELOCITY_Z,0) = 0.000000; -NODES[147](VELOCITY_X,0) = 0.000000; -NODES[147](VELOCITY_Y,0) = 0.000000; -NODES[147](VELOCITY_Z,0) = 0.000000; -NODES[148](VELOCITY_X,0) = 0.000000; -NODES[148](VELOCITY_Y,0) = 0.000000; -NODES[148](VELOCITY_Z,0) = 0.000000; -NODES[149](VELOCITY_X,0) = 0.000000; -NODES[149](VELOCITY_Y,0) = 0.000000; -NODES[149](VELOCITY_Z,0) = 0.000000; -NODES[150](VELOCITY_X,0) = 0.000000; -NODES[150](VELOCITY_Y,0) = 0.000000; -NODES[150](VELOCITY_Z,0) = 0.000000; -NODES[151](VELOCITY_X,0) = 0.000000; -NODES[151](VELOCITY_Y,0) = 0.000000; -NODES[151](VELOCITY_Z,0) = 0.000000; -NODES[152](VELOCITY_X,0) = 0.000000; -NODES[152](VELOCITY_Y,0) = 0.000000; -NODES[152](VELOCITY_Z,0) = 0.000000; -NODES[153](VELOCITY_X,0) = 0.000000; -NODES[153](VELOCITY_Y,0) = 0.000000; -NODES[153](VELOCITY_Z,0) = 0.000000; -NODES[154](VELOCITY_X,0) = 0.000000; -NODES[154](VELOCITY_Y,0) = 0.000000; -NODES[154](VELOCITY_Z,0) = 0.000000; -NODES[155](VELOCITY_X,0) = 0.000000; -NODES[155](VELOCITY_Y,0) = 0.000000; -NODES[155](VELOCITY_Z,0) = 0.000000; -NODES[156](VELOCITY_X,0) = 0.000000; -NODES[156](VELOCITY_Y,0) = 0.000000; -NODES[156](VELOCITY_Z,0) = 0.000000; -NODES[157](VELOCITY_X,0) = 0.000000; -NODES[157](VELOCITY_Y,0) = 0.000000; -NODES[157](VELOCITY_Z,0) = 0.000000; -NODES[158](VELOCITY_X,0) = 0.000000; -NODES[158](VELOCITY_Y,0) = 0.000000; -NODES[158](VELOCITY_Z,0) = 0.000000; -NODES[159](VELOCITY_X,0) = 0.000000; -NODES[159](VELOCITY_Y,0) = 0.000000; -NODES[159](VELOCITY_Z,0) = 0.000000; -NODES[160](VELOCITY_X,0) = 0.000000; -NODES[160](VELOCITY_Y,0) = 0.000000; -NODES[160](VELOCITY_Z,0) = 0.000000; -NODES[161](VELOCITY_X,0) = 0.000000; -NODES[161](VELOCITY_Y,0) = 0.000000; -NODES[161](VELOCITY_Z,0) = 0.000000; -NODES[162](VELOCITY_X,0) = 0.000000; -NODES[162](VELOCITY_Y,0) = 0.000000; -NODES[162](VELOCITY_Z,0) = 0.000000; -NODES[163](VELOCITY_X,0) = 0.000000; -NODES[163](VELOCITY_Y,0) = 0.000000; -NODES[163](VELOCITY_Z,0) = 0.000000; -NODES[164](VELOCITY_X,0) = 0.000000; -NODES[164](VELOCITY_Y,0) = 0.000000; -NODES[164](VELOCITY_Z,0) = 0.000000; -NODES[165](VELOCITY_X,0) = 0.000000; -NODES[165](VELOCITY_Y,0) = 0.000000; -NODES[165](VELOCITY_Z,0) = 0.000000; -NODES[166](VELOCITY_X,0) = 0.000000; -NODES[166](VELOCITY_Y,0) = 0.000000; -NODES[166](VELOCITY_Z,0) = 0.000000; -NODES[167](VELOCITY_X,0) = 0.000000; -NODES[167](VELOCITY_Y,0) = 0.000000; -NODES[167](VELOCITY_Z,0) = 0.000000; -NODES[168](VELOCITY_X,0) = 0.000000; -NODES[168](VELOCITY_Y,0) = 0.000000; -NODES[168](VELOCITY_Z,0) = 0.000000; -NODES[169](VELOCITY_X,0) = 0.000000; -NODES[169](VELOCITY_Y,0) = 0.000000; -NODES[169](VELOCITY_Z,0) = 0.000000; -NODES[170](VELOCITY_X,0) = 0.000000; -NODES[170](VELOCITY_Y,0) = 0.000000; -NODES[170](VELOCITY_Z,0) = 0.000000; -NODES[171](VELOCITY_X,0) = 0.000000; -NODES[171](VELOCITY_Y,0) = 0.000000; -NODES[171](VELOCITY_Z,0) = 0.000000; -NODES[172](VELOCITY_X,0) = 0.000000; -NODES[172](VELOCITY_Y,0) = 0.000000; -NODES[172](VELOCITY_Z,0) = 0.000000; -NODES[173](VELOCITY_X,0) = 0.000000; -NODES[173](VELOCITY_Y,0) = 0.000000; -NODES[173](VELOCITY_Z,0) = 0.000000; -NODES[174](VELOCITY_X,0) = 0.000000; -NODES[174](VELOCITY_Y,0) = 0.000000; -NODES[174](VELOCITY_Z,0) = 0.000000; -NODES[175](VELOCITY_X,0) = 0.000000; -NODES[175](VELOCITY_Y,0) = 0.000000; -NODES[175](VELOCITY_Z,0) = 0.000000; -NODES[176](VELOCITY_X,0) = 0.000000; -NODES[176](VELOCITY_Y,0) = 0.000000; -NODES[176](VELOCITY_Z,0) = 0.000000; -NODES[177](VELOCITY_X,0) = 0.000000; -NODES[177](VELOCITY_Y,0) = 0.000000; -NODES[177](VELOCITY_Z,0) = 0.000000; -NODES[178](VELOCITY_X,0) = 0.000000; -NODES[178](VELOCITY_Y,0) = 0.000000; -NODES[178](VELOCITY_Z,0) = 0.000000; -NODES[179](VELOCITY_X,0) = 0.000000; -NODES[179](VELOCITY_Y,0) = 0.000000; -NODES[179](VELOCITY_Z,0) = 0.000000; -NODES[180](VELOCITY_X,0) = 0.000000; -NODES[180](VELOCITY_Y,0) = 0.000000; -NODES[180](VELOCITY_Z,0) = 0.000000; -NODES[181](VELOCITY_X,0) = 0.000000; -NODES[181](VELOCITY_Y,0) = 0.000000; -NODES[181](VELOCITY_Z,0) = 0.000000; -NODES[182](VELOCITY_X,0) = 0.000000; -NODES[182](VELOCITY_Y,0) = 0.000000; -NODES[182](VELOCITY_Z,0) = 0.000000; -NODES[183](VELOCITY_X,0) = 0.000000; -NODES[183](VELOCITY_Y,0) = 0.000000; -NODES[183](VELOCITY_Z,0) = 0.000000; -NODES[184](VELOCITY_X,0) = 0.000000; -NODES[184](VELOCITY_Y,0) = 0.000000; -NODES[184](VELOCITY_Z,0) = 0.000000; -NODES[185](VELOCITY_X,0) = 0.000000; -NODES[185](VELOCITY_Y,0) = 0.000000; -NODES[185](VELOCITY_Z,0) = 0.000000; -NODES[186](VELOCITY_X,0) = 0.000000; -NODES[186](VELOCITY_Y,0) = 0.000000; -NODES[186](VELOCITY_Z,0) = 0.000000; -NODES[187](VELOCITY_X,0) = 0.000000; -NODES[187](VELOCITY_Y,0) = 0.000000; -NODES[187](VELOCITY_Z,0) = 0.000000; -NODES[188](VELOCITY_X,0) = 0.000000; -NODES[188](VELOCITY_Y,0) = 0.000000; -NODES[188](VELOCITY_Z,0) = 0.000000; -NODES[189](VELOCITY_X,0) = 0.000000; -NODES[189](VELOCITY_Y,0) = 0.000000; -NODES[189](VELOCITY_Z,0) = 0.000000; -NODES[190](VELOCITY_X,0) = 0.000000; -NODES[190](VELOCITY_Y,0) = 0.000000; -NODES[190](VELOCITY_Z,0) = 0.000000; -NODES[191](VELOCITY_X,0) = 0.000000; -NODES[191](VELOCITY_Y,0) = 0.000000; -NODES[191](VELOCITY_Z,0) = 0.000000; -NODES[192](VELOCITY_X,0) = 0.000000; -NODES[192](VELOCITY_Y,0) = 0.000000; -NODES[192](VELOCITY_Z,0) = 0.000000; -NODES[193](VELOCITY_X,0) = 0.000000; -NODES[193](VELOCITY_Y,0) = 0.000000; -NODES[193](VELOCITY_Z,0) = 0.000000; -NODES[194](VELOCITY_X,0) = 0.000000; -NODES[194](VELOCITY_Y,0) = 0.000000; -NODES[194](VELOCITY_Z,0) = 0.000000; -NODES[195](VELOCITY_X,0) = 0.000000; -NODES[195](VELOCITY_Y,0) = 0.000000; -NODES[195](VELOCITY_Z,0) = 0.000000; -NODES[196](VELOCITY_X,0) = 0.000000; -NODES[196](VELOCITY_Y,0) = 0.000000; -NODES[196](VELOCITY_Z,0) = 0.000000; -NODES[197](VELOCITY_X,0) = 0.000000; -NODES[197](VELOCITY_Y,0) = 0.000000; -NODES[197](VELOCITY_Z,0) = 0.000000; -NODES[198](VELOCITY_X,0) = 0.000000; -NODES[198](VELOCITY_Y,0) = 0.000000; -NODES[198](VELOCITY_Z,0) = 0.000000; -NODES[199](VELOCITY_X,0) = 0.000000; -NODES[199](VELOCITY_Y,0) = 0.000000; -NODES[199](VELOCITY_Z,0) = 0.000000; -NODES[200](VELOCITY_X,0) = 0.000000; -NODES[200](VELOCITY_Y,0) = 0.000000; -NODES[200](VELOCITY_Z,0) = 0.000000; -NODES[201](VELOCITY_X,0) = 0.000000; -NODES[201](VELOCITY_Y,0) = 0.000000; -NODES[201](VELOCITY_Z,0) = 0.000000; -NODES[202](VELOCITY_X,0) = 0.000000; -NODES[202](VELOCITY_Y,0) = 0.000000; -NODES[202](VELOCITY_Z,0) = 0.000000; -NODES[203](VELOCITY_X,0) = 0.000000; -NODES[203](VELOCITY_Y,0) = 0.000000; -NODES[203](VELOCITY_Z,0) = 0.000000; -NODES[204](VELOCITY_X,0) = 0.000000; -NODES[204](VELOCITY_Y,0) = 0.000000; -NODES[204](VELOCITY_Z,0) = 0.000000; -NODES[205](VELOCITY_X,0) = 0.000000; -NODES[205](VELOCITY_Y,0) = 0.000000; -NODES[205](VELOCITY_Z,0) = 0.000000; -NODES[206](VELOCITY_X,0) = 0.000000; -NODES[206](VELOCITY_Y,0) = 0.000000; -NODES[206](VELOCITY_Z,0) = 0.000000; -NODES[207](VELOCITY_X,0) = 0.000000; -NODES[207](VELOCITY_Y,0) = 0.000000; -NODES[207](VELOCITY_Z,0) = 0.000000; -NODES[208](VELOCITY_X,0) = 0.000000; -NODES[208](VELOCITY_Y,0) = 0.000000; -NODES[208](VELOCITY_Z,0) = 0.000000; -NODES[209](VELOCITY_X,0) = 0.000000; -NODES[209](VELOCITY_Y,0) = 0.000000; -NODES[209](VELOCITY_Z,0) = 0.000000; -NODES[210](VELOCITY_X,0) = 0.000000; -NODES[210](VELOCITY_Y,0) = 0.000000; -NODES[210](VELOCITY_Z,0) = 0.000000; -NODES[211](VELOCITY_X,0) = 0.000000; -NODES[211](VELOCITY_Y,0) = 0.000000; -NODES[211](VELOCITY_Z,0) = 0.000000; -NODES[212](VELOCITY_X,0) = 0.000000; -NODES[212](VELOCITY_Y,0) = 0.000000; -NODES[212](VELOCITY_Z,0) = 0.000000; -NODES[213](VELOCITY_X,0) = 0.000000; -NODES[213](VELOCITY_Y,0) = 0.000000; -NODES[213](VELOCITY_Z,0) = 0.000000; -NODES[214](VELOCITY_X,0) = 0.000000; -NODES[214](VELOCITY_Y,0) = 0.000000; -NODES[214](VELOCITY_Z,0) = 0.000000; -NODES[215](VELOCITY_X,0) = 0.000000; -NODES[215](VELOCITY_Y,0) = 0.000000; -NODES[215](VELOCITY_Z,0) = 0.000000; -NODES[216](VELOCITY_X,0) = 0.000000; -NODES[216](VELOCITY_Y,0) = 0.000000; -NODES[216](VELOCITY_Z,0) = 0.000000; -NODES[217](VELOCITY_X,0) = 0.000000; -NODES[217](VELOCITY_Y,0) = 0.000000; -NODES[217](VELOCITY_Z,0) = 0.000000; -NODES[218](VELOCITY_X,0) = 0.000000; -NODES[218](VELOCITY_Y,0) = 0.000000; -NODES[218](VELOCITY_Z,0) = 0.000000; -NODES[219](VELOCITY_X,0) = 0.000000; -NODES[219](VELOCITY_Y,0) = 0.000000; -NODES[219](VELOCITY_Z,0) = 0.000000; -NODES[220](VELOCITY_X,0) = 0.000000; -NODES[220](VELOCITY_Y,0) = 0.000000; -NODES[220](VELOCITY_Z,0) = 0.000000; -NODES[221](VELOCITY_X,0) = 0.000000; -NODES[221](VELOCITY_Y,0) = 0.000000; -NODES[221](VELOCITY_Z,0) = 0.000000; -NODES[222](VELOCITY_X,0) = 0.000000; -NODES[222](VELOCITY_Y,0) = 0.000000; -NODES[222](VELOCITY_Z,0) = 0.000000; -NODES[223](VELOCITY_X,0) = 0.000000; -NODES[223](VELOCITY_Y,0) = 0.000000; -NODES[223](VELOCITY_Z,0) = 0.000000; -NODES[224](VELOCITY_X,0) = 0.000000; -NODES[224](VELOCITY_Y,0) = 0.000000; -NODES[224](VELOCITY_Z,0) = 0.000000; -NODES[225](VELOCITY_X,0) = 0.000000; -NODES[225](VELOCITY_Y,0) = 0.000000; -NODES[225](VELOCITY_Z,0) = 0.000000; -NODES[226](VELOCITY_X,0) = 0.000000; -NODES[226](VELOCITY_Y,0) = 0.000000; -NODES[226](VELOCITY_Z,0) = 0.000000; -NODES[227](VELOCITY_X,0) = 0.000000; -NODES[227](VELOCITY_Y,0) = 0.000000; -NODES[227](VELOCITY_Z,0) = 0.000000; -NODES[228](VELOCITY_X,0) = 0.000000; -NODES[228](VELOCITY_Y,0) = 0.000000; -NODES[228](VELOCITY_Z,0) = 0.000000; -NODES[229](VELOCITY_X,0) = 0.000000; -NODES[229](VELOCITY_Y,0) = 0.000000; -NODES[229](VELOCITY_Z,0) = 0.000000; -NODES[230](VELOCITY_X,0) = 0.000000; -NODES[230](VELOCITY_Y,0) = 0.000000; -NODES[230](VELOCITY_Z,0) = 0.000000; -NODES[231](VELOCITY_X,0) = 0.000000; -NODES[231](VELOCITY_Y,0) = 0.000000; -NODES[231](VELOCITY_Z,0) = 0.000000; -NODES[232](VELOCITY_X,0) = 0.000000; -NODES[232](VELOCITY_Y,0) = 0.000000; -NODES[232](VELOCITY_Z,0) = 0.000000; -NODES[233](VELOCITY_X,0) = 0.000000; -NODES[233](VELOCITY_Y,0) = 0.000000; -NODES[233](VELOCITY_Z,0) = 0.000000; -NODES[234](VELOCITY_X,0) = 0.000000; -NODES[234](VELOCITY_Y,0) = 0.000000; -NODES[234](VELOCITY_Z,0) = 0.000000; -NODES[235](VELOCITY_X,0) = 0.000000; -NODES[235](VELOCITY_Y,0) = 0.000000; -NODES[235](VELOCITY_Z,0) = 0.000000; -NODES[236](VELOCITY_X,0) = 0.000000; -NODES[236](VELOCITY_Y,0) = 0.000000; -NODES[236](VELOCITY_Z,0) = 0.000000; -NODES[237](VELOCITY_X,0) = 0.000000; -NODES[237](VELOCITY_Y,0) = 0.000000; -NODES[237](VELOCITY_Z,0) = 0.000000; -NODES[238](VELOCITY_X,0) = 0.000000; -NODES[238](VELOCITY_Y,0) = 0.000000; -NODES[238](VELOCITY_Z,0) = 0.000000; -NODES[239](VELOCITY_X,0) = 0.000000; -NODES[239](VELOCITY_Y,0) = 0.000000; -NODES[239](VELOCITY_Z,0) = 0.000000; -NODES[240](VELOCITY_X,0) = 0.000000; -NODES[240](VELOCITY_Y,0) = 0.000000; -NODES[240](VELOCITY_Z,0) = 0.000000; -NODES[241](VELOCITY_X,0) = 0.000000; -NODES[241](VELOCITY_Y,0) = 0.000000; -NODES[241](VELOCITY_Z,0) = 0.000000; -NODES[242](VELOCITY_X,0) = 0.000000; -NODES[242](VELOCITY_Y,0) = 0.000000; -NODES[242](VELOCITY_Z,0) = 0.000000; -NODES[243](VELOCITY_X,0) = 0.000000; -NODES[243](VELOCITY_Y,0) = 0.000000; -NODES[243](VELOCITY_Z,0) = 0.000000; -NODES[244](VELOCITY_X,0) = 0.000000; -NODES[244](VELOCITY_Y,0) = 0.000000; -NODES[244](VELOCITY_Z,0) = 0.000000; -NODES[245](VELOCITY_X,0) = 0.000000; -NODES[245](VELOCITY_Y,0) = 0.000000; -NODES[245](VELOCITY_Z,0) = 0.000000; -NODES[246](VELOCITY_X,0) = 0.000000; -NODES[246](VELOCITY_Y,0) = 0.000000; -NODES[246](VELOCITY_Z,0) = 0.000000; -NODES[247](VELOCITY_X,0) = 0.000000; -NODES[247](VELOCITY_Y,0) = 0.000000; -NODES[247](VELOCITY_Z,0) = 0.000000; -NODES[248](VELOCITY_X,0) = 0.000000; -NODES[248](VELOCITY_Y,0) = 0.000000; -NODES[248](VELOCITY_Z,0) = 0.000000; -NODES[249](VELOCITY_X,0) = 0.000000; -NODES[249](VELOCITY_Y,0) = 0.000000; -NODES[249](VELOCITY_Z,0) = 0.000000; -NODES[250](VELOCITY_X,0) = 0.000000; -NODES[250](VELOCITY_Y,0) = 0.000000; -NODES[250](VELOCITY_Z,0) = 0.000000; -NODES[251](VELOCITY_X,0) = 0.000000; -NODES[251](VELOCITY_Y,0) = 0.000000; -NODES[251](VELOCITY_Z,0) = 0.000000; -NODES[252](VELOCITY_X,0) = 0.000000; -NODES[252](VELOCITY_Y,0) = 0.000000; -NODES[252](VELOCITY_Z,0) = 0.000000; -NODES[253](VELOCITY_X,0) = 0.000000; -NODES[253](VELOCITY_Y,0) = 0.000000; -NODES[253](VELOCITY_Z,0) = 0.000000; -NODES[254](VELOCITY_X,0) = 0.000000; -NODES[254](VELOCITY_Y,0) = 0.000000; -NODES[254](VELOCITY_Z,0) = 0.000000; -NODES[255](VELOCITY_X,0) = 0.000000; -NODES[255](VELOCITY_Y,0) = 0.000000; -NODES[255](VELOCITY_Z,0) = 0.000000; -NODES[256](VELOCITY_X,0) = 0.000000; -NODES[256](VELOCITY_Y,0) = 0.000000; -NODES[256](VELOCITY_Z,0) = 0.000000; -NODES[257](VELOCITY_X,0) = 0.000000; -NODES[257](VELOCITY_Y,0) = 0.000000; -NODES[257](VELOCITY_Z,0) = 0.000000; -NODES[258](VELOCITY_X,0) = 0.000000; -NODES[258](VELOCITY_Y,0) = 0.000000; -NODES[258](VELOCITY_Z,0) = 0.000000; -NODES[259](VELOCITY_X,0) = 0.000000; -NODES[259](VELOCITY_Y,0) = 0.000000; -NODES[259](VELOCITY_Z,0) = 0.000000; -NODES[260](VELOCITY_X,0) = 0.000000; -NODES[260](VELOCITY_Y,0) = 0.000000; -NODES[260](VELOCITY_Z,0) = 0.000000; -NODES[261](VELOCITY_X,0) = 0.000000; -NODES[261](VELOCITY_Y,0) = 0.000000; -NODES[261](VELOCITY_Z,0) = 0.000000; -NODES[262](VELOCITY_X,0) = 0.000000; -NODES[262](VELOCITY_Y,0) = 0.000000; -NODES[262](VELOCITY_Z,0) = 0.000000; -NODES[263](VELOCITY_X,0) = 0.000000; -NODES[263](VELOCITY_Y,0) = 0.000000; -NODES[263](VELOCITY_Z,0) = 0.000000; -NODES[264](VELOCITY_X,0) = 0.000000; -NODES[264](VELOCITY_Y,0) = 0.000000; -NODES[264](VELOCITY_Z,0) = 0.000000; -NODES[265](VELOCITY_X,0) = 0.000000; -NODES[265](VELOCITY_Y,0) = 0.000000; -NODES[265](VELOCITY_Z,0) = 0.000000; -NODES[266](VELOCITY_X,0) = 0.000000; -NODES[266](VELOCITY_Y,0) = 0.000000; -NODES[266](VELOCITY_Z,0) = 0.000000; -NODES[267](VELOCITY_X,0) = 0.000000; -NODES[267](VELOCITY_Y,0) = 0.000000; -NODES[267](VELOCITY_Z,0) = 0.000000; -NODES[268](VELOCITY_X,0) = 0.000000; -NODES[268](VELOCITY_Y,0) = 0.000000; -NODES[268](VELOCITY_Z,0) = 0.000000; -NODES[269](VELOCITY_X,0) = 0.000000; -NODES[269](VELOCITY_Y,0) = 0.000000; -NODES[269](VELOCITY_Z,0) = 0.000000; -NODES[270](VELOCITY_X,0) = 0.000000; -NODES[270](VELOCITY_Y,0) = 0.000000; -NODES[270](VELOCITY_Z,0) = 0.000000; -NODES[271](VELOCITY_X,0) = 0.000000; -NODES[271](VELOCITY_Y,0) = 0.000000; -NODES[271](VELOCITY_Z,0) = 0.000000; -NODES[272](VELOCITY_X,0) = 0.000000; -NODES[272](VELOCITY_Y,0) = 0.000000; -NODES[272](VELOCITY_Z,0) = 0.000000; -NODES[273](VELOCITY_X,0) = 0.000000; -NODES[273](VELOCITY_Y,0) = 0.000000; -NODES[273](VELOCITY_Z,0) = 0.000000; -NODES[274](VELOCITY_X,0) = 0.000000; -NODES[274](VELOCITY_Y,0) = 0.000000; -NODES[274](VELOCITY_Z,0) = 0.000000; -NODES[275](VELOCITY_X,0) = 0.000000; -NODES[275](VELOCITY_Y,0) = 0.000000; -NODES[275](VELOCITY_Z,0) = 0.000000; -NODES[276](VELOCITY_X,0) = 0.000000; -NODES[276](VELOCITY_Y,0) = 0.000000; -NODES[276](VELOCITY_Z,0) = 0.000000; -NODES[277](VELOCITY_X,0) = 0.000000; -NODES[277](VELOCITY_Y,0) = 0.000000; -NODES[277](VELOCITY_Z,0) = 0.000000; -NODES[278](VELOCITY_X,0) = 0.000000; -NODES[278](VELOCITY_Y,0) = 0.000000; -NODES[278](VELOCITY_Z,0) = 0.000000; -NODES[279](VELOCITY_X,0) = 0.000000; -NODES[279](VELOCITY_Y,0) = 0.000000; -NODES[279](VELOCITY_Z,0) = 0.000000; -NODES[280](VELOCITY_X,0) = 0.000000; -NODES[280](VELOCITY_Y,0) = 0.000000; -NODES[280](VELOCITY_Z,0) = 0.000000; -NODES[281](VELOCITY_X,0) = 0.000000; -NODES[281](VELOCITY_Y,0) = 0.000000; -NODES[281](VELOCITY_Z,0) = 0.000000; -NODES[282](VELOCITY_X,0) = 0.000000; -NODES[282](VELOCITY_Y,0) = 0.000000; -NODES[282](VELOCITY_Z,0) = 0.000000; -NODES[283](VELOCITY_X,0) = 0.000000; -NODES[283](VELOCITY_Y,0) = 0.000000; -NODES[283](VELOCITY_Z,0) = 0.000000; -NODES[284](VELOCITY_X,0) = 0.000000; -NODES[284](VELOCITY_Y,0) = 0.000000; -NODES[284](VELOCITY_Z,0) = 0.000000; -NODES[285](VELOCITY_X,0) = 0.000000; -NODES[285](VELOCITY_Y,0) = 0.000000; -NODES[285](VELOCITY_Z,0) = 0.000000; -NODES[286](VELOCITY_X,0) = 0.000000; -NODES[286](VELOCITY_Y,0) = 0.000000; -NODES[286](VELOCITY_Z,0) = 0.000000; -NODES[287](VELOCITY_X,0) = 0.000000; -NODES[287](VELOCITY_Y,0) = 0.000000; -NODES[287](VELOCITY_Z,0) = 0.000000; -NODES[288](VELOCITY_X,0) = 0.000000; -NODES[288](VELOCITY_Y,0) = 0.000000; -NODES[288](VELOCITY_Z,0) = 0.000000; -NODES[289](VELOCITY_X,0) = 0.000000; -NODES[289](VELOCITY_Y,0) = 0.000000; -NODES[289](VELOCITY_Z,0) = 0.000000; -NODES[290](VELOCITY_X,0) = 0.000000; -NODES[290](VELOCITY_Y,0) = 0.000000; -NODES[290](VELOCITY_Z,0) = 0.000000; -NODES[291](VELOCITY_X,0) = 0.000000; -NODES[291](VELOCITY_Y,0) = 0.000000; -NODES[291](VELOCITY_Z,0) = 0.000000; -NODES[292](VELOCITY_X,0) = 0.000000; -NODES[292](VELOCITY_Y,0) = 0.000000; -NODES[292](VELOCITY_Z,0) = 0.000000; -NODES[293](VELOCITY_X,0) = 0.000000; -NODES[293](VELOCITY_Y,0) = 0.000000; -NODES[293](VELOCITY_Z,0) = 0.000000; -NODES[294](VELOCITY_X,0) = 0.000000; -NODES[294](VELOCITY_Y,0) = 0.000000; -NODES[294](VELOCITY_Z,0) = 0.000000; -NODES[295](VELOCITY_X,0) = 0.000000; -NODES[295](VELOCITY_Y,0) = 0.000000; -NODES[295](VELOCITY_Z,0) = 0.000000; -NODES[296](VELOCITY_X,0) = 0.000000; -NODES[296](VELOCITY_Y,0) = 0.000000; -NODES[296](VELOCITY_Z,0) = 0.000000; -NODES[297](VELOCITY_X,0) = 0.000000; -NODES[297](VELOCITY_Y,0) = 0.000000; -NODES[297](VELOCITY_Z,0) = 0.000000; -NODES[298](VELOCITY_X,0) = 0.000000; -NODES[298](VELOCITY_Y,0) = 0.000000; -NODES[298](VELOCITY_Z,0) = 0.000000; -NODES[299](VELOCITY_X,0) = 0.000000; -NODES[299](VELOCITY_Y,0) = 0.000000; -NODES[299](VELOCITY_Z,0) = 0.000000; -NODES[300](VELOCITY_X,0) = 0.000000; -NODES[300](VELOCITY_Y,0) = 0.000000; -NODES[300](VELOCITY_Z,0) = 0.000000; -NODES[301](VELOCITY_X,0) = 0.000000; -NODES[301](VELOCITY_Y,0) = 0.000000; -NODES[301](VELOCITY_Z,0) = 0.000000; -NODES[302](VELOCITY_X,0) = 0.000000; -NODES[302](VELOCITY_Y,0) = 0.000000; -NODES[302](VELOCITY_Z,0) = 0.000000; -NODES[303](VELOCITY_X,0) = 0.000000; -NODES[303](VELOCITY_Y,0) = 0.000000; -NODES[303](VELOCITY_Z,0) = 0.000000; -NODES[304](VELOCITY_X,0) = 0.000000; -NODES[304](VELOCITY_Y,0) = 0.000000; -NODES[304](VELOCITY_Z,0) = 0.000000; -NODES[305](VELOCITY_X,0) = 0.000000; -NODES[305](VELOCITY_Y,0) = 0.000000; -NODES[305](VELOCITY_Z,0) = 0.000000; -NODES[306](VELOCITY_X,0) = 0.000000; -NODES[306](VELOCITY_Y,0) = 0.000000; -NODES[306](VELOCITY_Z,0) = 0.000000; -NODES[307](VELOCITY_X,0) = 0.000000; -NODES[307](VELOCITY_Y,0) = 0.000000; -NODES[307](VELOCITY_Z,0) = 0.000000; -NODES[308](VELOCITY_X,0) = 0.000000; -NODES[308](VELOCITY_Y,0) = 0.000000; -NODES[308](VELOCITY_Z,0) = 0.000000; -NODES[309](VELOCITY_X,0) = 0.000000; -NODES[309](VELOCITY_Y,0) = 0.000000; -NODES[309](VELOCITY_Z,0) = 0.000000; -NODES[310](VELOCITY_X,0) = 0.000000; -NODES[310](VELOCITY_Y,0) = 0.000000; -NODES[310](VELOCITY_Z,0) = 0.000000; -NODES[311](VELOCITY_X,0) = 0.000000; -NODES[311](VELOCITY_Y,0) = 0.000000; -NODES[311](VELOCITY_Z,0) = 0.000000; -NODES[312](VELOCITY_X,0) = 0.000000; -NODES[312](VELOCITY_Y,0) = 0.000000; -NODES[312](VELOCITY_Z,0) = 0.000000; -NODES[313](VELOCITY_X,0) = 0.000000; -NODES[313](VELOCITY_Y,0) = 0.000000; -NODES[313](VELOCITY_Z,0) = 0.000000; -NODES[314](VELOCITY_X,0) = 0.000000; -NODES[314](VELOCITY_Y,0) = 0.000000; -NODES[314](VELOCITY_Z,0) = 0.000000; -NODES[315](VELOCITY_X,0) = 0.000000; -NODES[315](VELOCITY_Y,0) = 0.000000; -NODES[315](VELOCITY_Z,0) = 0.000000; -NODES[316](VELOCITY_X,0) = 0.000000; -NODES[316](VELOCITY_Y,0) = 0.000000; -NODES[316](VELOCITY_Z,0) = 0.000000; -NODES[317](VELOCITY_X,0) = 0.000000; -NODES[317](VELOCITY_Y,0) = 0.000000; -NODES[317](VELOCITY_Z,0) = 0.000000; -NODES[318](VELOCITY_X,0) = 0.000000; -NODES[318](VELOCITY_Y,0) = 0.000000; -NODES[318](VELOCITY_Z,0) = 0.000000; -NODES[319](VELOCITY_X,0) = 0.000000; -NODES[319](VELOCITY_Y,0) = 0.000000; -NODES[319](VELOCITY_Z,0) = 0.000000; -NODES[320](VELOCITY_X,0) = 0.000000; -NODES[320](VELOCITY_Y,0) = 0.000000; -NODES[320](VELOCITY_Z,0) = 0.000000; -NODES[321](VELOCITY_X,0) = 0.000000; -NODES[321](VELOCITY_Y,0) = 0.000000; -NODES[321](VELOCITY_Z,0) = 0.000000; -NODES[322](VELOCITY_X,0) = 0.000000; -NODES[322](VELOCITY_Y,0) = 0.000000; -NODES[322](VELOCITY_Z,0) = 0.000000; -NODES[323](VELOCITY_X,0) = 0.000000; -NODES[323](VELOCITY_Y,0) = 0.000000; -NODES[323](VELOCITY_Z,0) = 0.000000; -NODES[324](VELOCITY_X,0) = 0.000000; -NODES[324](VELOCITY_Y,0) = 0.000000; -NODES[324](VELOCITY_Z,0) = 0.000000; -NODES[325](VELOCITY_X,0) = 0.000000; -NODES[325](VELOCITY_Y,0) = 0.000000; -NODES[325](VELOCITY_Z,0) = 0.000000; -NODES[326](VELOCITY_X,0) = 0.000000; -NODES[326](VELOCITY_Y,0) = 0.000000; -NODES[326](VELOCITY_Z,0) = 0.000000; -NODES[327](VELOCITY_X,0) = 0.000000; -NODES[327](VELOCITY_Y,0) = 0.000000; -NODES[327](VELOCITY_Z,0) = 0.000000; -NODES[328](VELOCITY_X,0) = 0.000000; -NODES[328](VELOCITY_Y,0) = 0.000000; -NODES[328](VELOCITY_Z,0) = 0.000000; -NODES[329](VELOCITY_X,0) = 0.000000; -NODES[329](VELOCITY_Y,0) = 0.000000; -NODES[329](VELOCITY_Z,0) = 0.000000; -NODES[330](VELOCITY_X,0) = 0.000000; -NODES[330](VELOCITY_Y,0) = 0.000000; -NODES[330](VELOCITY_Z,0) = 0.000000; -NODES[331](VELOCITY_X,0) = 0.000000; -NODES[331](VELOCITY_Y,0) = 0.000000; -NODES[331](VELOCITY_Z,0) = 0.000000; -NODES[332](VELOCITY_X,0) = 0.000000; -NODES[332](VELOCITY_Y,0) = 0.000000; -NODES[332](VELOCITY_Z,0) = 0.000000; -NODES[333](VELOCITY_X,0) = 0.000000; -NODES[333](VELOCITY_Y,0) = 0.000000; -NODES[333](VELOCITY_Z,0) = 0.000000; -NODES[334](VELOCITY_X,0) = 0.000000; -NODES[334](VELOCITY_Y,0) = 0.000000; -NODES[334](VELOCITY_Z,0) = 0.000000; -NODES[335](VELOCITY_X,0) = 0.000000; -NODES[335](VELOCITY_Y,0) = 0.000000; -NODES[335](VELOCITY_Z,0) = 0.000000; -NODES[336](VELOCITY_X,0) = 0.000000; -NODES[336](VELOCITY_Y,0) = 0.000000; -NODES[336](VELOCITY_Z,0) = 0.000000; -NODES[337](VELOCITY_X,0) = 0.000000; -NODES[337](VELOCITY_Y,0) = 0.000000; -NODES[337](VELOCITY_Z,0) = 0.000000; -NODES[338](VELOCITY_X,0) = 0.000000; -NODES[338](VELOCITY_Y,0) = 0.000000; -NODES[338](VELOCITY_Z,0) = 0.000000; -NODES[339](VELOCITY_X,0) = 0.000000; -NODES[339](VELOCITY_Y,0) = 0.000000; -NODES[339](VELOCITY_Z,0) = 0.000000; -NODES[340](VELOCITY_X,0) = 0.000000; -NODES[340](VELOCITY_Y,0) = 0.000000; -NODES[340](VELOCITY_Z,0) = 0.000000; -NODES[341](VELOCITY_X,0) = 0.000000; -NODES[341](VELOCITY_Y,0) = 0.000000; -NODES[341](VELOCITY_Z,0) = 0.000000; -NODES[342](VELOCITY_X,0) = 0.000000; -NODES[342](VELOCITY_Y,0) = 0.000000; -NODES[342](VELOCITY_Z,0) = 0.000000; -NODES[343](VELOCITY_X,0) = 0.000000; -NODES[343](VELOCITY_Y,0) = 0.000000; -NODES[343](VELOCITY_Z,0) = 0.000000; -NODES[344](VELOCITY_X,0) = 0.000000; -NODES[344](VELOCITY_Y,0) = 0.000000; -NODES[344](VELOCITY_Z,0) = 0.000000; -NODES[345](VELOCITY_X,0) = 0.000000; -NODES[345](VELOCITY_Y,0) = 0.000000; -NODES[345](VELOCITY_Z,0) = 0.000000; -NODES[346](VELOCITY_X,0) = 0.000000; -NODES[346](VELOCITY_Y,0) = 0.000000; -NODES[346](VELOCITY_Z,0) = 0.000000; -NODES[347](VELOCITY_X,0) = 0.000000; -NODES[347](VELOCITY_Y,0) = 0.000000; -NODES[347](VELOCITY_Z,0) = 0.000000; -NODES[348](VELOCITY_X,0) = 0.000000; -NODES[348](VELOCITY_Y,0) = 0.000000; -NODES[348](VELOCITY_Z,0) = 0.000000; -NODES[349](VELOCITY_X,0) = 0.000000; -NODES[349](VELOCITY_Y,0) = 0.000000; -NODES[349](VELOCITY_Z,0) = 0.000000; -NODES[350](VELOCITY_X,0) = 0.000000; -NODES[350](VELOCITY_Y,0) = 0.000000; -NODES[350](VELOCITY_Z,0) = 0.000000; -NODES[351](VELOCITY_X,0) = 0.000000; -NODES[351](VELOCITY_Y,0) = 0.000000; -NODES[351](VELOCITY_Z,0) = 0.000000; -NODES[352](VELOCITY_X,0) = 0.000000; -NODES[352](VELOCITY_Y,0) = 0.000000; -NODES[352](VELOCITY_Z,0) = 0.000000; -NODES[353](VELOCITY_X,0) = 0.000000; -NODES[353](VELOCITY_Y,0) = 0.000000; -NODES[353](VELOCITY_Z,0) = 0.000000; -NODES[354](VELOCITY_X,0) = 0.000000; -NODES[354](VELOCITY_Y,0) = 0.000000; -NODES[354](VELOCITY_Z,0) = 0.000000; -NODES[355](VELOCITY_X,0) = 0.000000; -NODES[355](VELOCITY_Y,0) = 0.000000; -NODES[355](VELOCITY_Z,0) = 0.000000; -NODES[356](VELOCITY_X,0) = 0.000000; -NODES[356](VELOCITY_Y,0) = 0.000000; -NODES[356](VELOCITY_Z,0) = 0.000000; -NODES[357](VELOCITY_X,0) = 0.000000; -NODES[357](VELOCITY_Y,0) = 0.000000; -NODES[357](VELOCITY_Z,0) = 0.000000; -NODES[358](VELOCITY_X,0) = 0.000000; -NODES[358](VELOCITY_Y,0) = 0.000000; -NODES[358](VELOCITY_Z,0) = 0.000000; -NODES[359](VELOCITY_X,0) = 0.000000; -NODES[359](VELOCITY_Y,0) = 0.000000; -NODES[359](VELOCITY_Z,0) = 0.000000; -NODES[360](VELOCITY_X,0) = 0.000000; -NODES[360](VELOCITY_Y,0) = 0.000000; -NODES[360](VELOCITY_Z,0) = 0.000000; -NODES[361](VELOCITY_X,0) = 0.000000; -NODES[361](VELOCITY_Y,0) = 0.000000; -NODES[361](VELOCITY_Z,0) = 0.000000; -NODES[362](VELOCITY_X,0) = 0.000000; -NODES[362](VELOCITY_Y,0) = 0.000000; -NODES[362](VELOCITY_Z,0) = 0.000000; -NODES[363](VELOCITY_X,0) = 0.000000; -NODES[363](VELOCITY_Y,0) = 0.000000; -NODES[363](VELOCITY_Z,0) = 0.000000; -NODES[364](VELOCITY_X,0) = 0.000000; -NODES[364](VELOCITY_Y,0) = 0.000000; -NODES[364](VELOCITY_Z,0) = 0.000000; -NODES[365](VELOCITY_X,0) = 0.000000; -NODES[365](VELOCITY_Y,0) = 0.000000; -NODES[365](VELOCITY_Z,0) = 0.000000; -NODES[366](VELOCITY_X,0) = 0.000000; -NODES[366](VELOCITY_Y,0) = 0.000000; -NODES[366](VELOCITY_Z,0) = 0.000000; -NODES[367](VELOCITY_X,0) = 0.000000; -NODES[367](VELOCITY_Y,0) = 0.000000; -NODES[367](VELOCITY_Z,0) = 0.000000; -NODES[368](VELOCITY_X,0) = 0.000000; -NODES[368](VELOCITY_Y,0) = 0.000000; -NODES[368](VELOCITY_Z,0) = 0.000000; -NODES[369](VELOCITY_X,0) = 0.000000; -NODES[369](VELOCITY_Y,0) = 0.000000; -NODES[369](VELOCITY_Z,0) = 0.000000; -NODES[370](VELOCITY_X,0) = 0.000000; -NODES[370](VELOCITY_Y,0) = 0.000000; -NODES[370](VELOCITY_Z,0) = 0.000000; -NODES[371](VELOCITY_X,0) = 0.000000; -NODES[371](VELOCITY_Y,0) = 0.000000; -NODES[371](VELOCITY_Z,0) = 0.000000; -NODES[372](VELOCITY_X,0) = 0.000000; -NODES[372](VELOCITY_Y,0) = 0.000000; -NODES[372](VELOCITY_Z,0) = 0.000000; -NODES[373](VELOCITY_X,0) = 0.000000; -NODES[373](VELOCITY_Y,0) = 0.000000; -NODES[373](VELOCITY_Z,0) = 0.000000; -NODES[374](VELOCITY_X,0) = 0.000000; -NODES[374](VELOCITY_Y,0) = 0.000000; -NODES[374](VELOCITY_Z,0) = 0.000000; -NODES[375](VELOCITY_X,0) = 0.000000; -NODES[375](VELOCITY_Y,0) = 0.000000; -NODES[375](VELOCITY_Z,0) = 0.000000; -NODES[376](VELOCITY_X,0) = 0.000000; -NODES[376](VELOCITY_Y,0) = 0.000000; -NODES[376](VELOCITY_Z,0) = 0.000000; -NODES[377](VELOCITY_X,0) = 0.000000; -NODES[377](VELOCITY_Y,0) = 0.000000; -NODES[377](VELOCITY_Z,0) = 0.000000; -NODES[378](VELOCITY_X,0) = 0.000000; -NODES[378](VELOCITY_Y,0) = 0.000000; -NODES[378](VELOCITY_Z,0) = 0.000000; -NODES[379](VELOCITY_X,0) = 0.000000; -NODES[379](VELOCITY_Y,0) = 0.000000; -NODES[379](VELOCITY_Z,0) = 0.000000; -NODES[380](VELOCITY_X,0) = 0.000000; -NODES[380](VELOCITY_Y,0) = 0.000000; -NODES[380](VELOCITY_Z,0) = 0.000000; -NODES[381](VELOCITY_X,0) = 0.000000; -NODES[381](VELOCITY_Y,0) = 0.000000; -NODES[381](VELOCITY_Z,0) = 0.000000; -NODES[382](VELOCITY_X,0) = 0.000000; -NODES[382](VELOCITY_Y,0) = 0.000000; -NODES[382](VELOCITY_Z,0) = 0.000000; -NODES[383](VELOCITY_X,0) = 0.000000; -NODES[383](VELOCITY_Y,0) = 0.000000; -NODES[383](VELOCITY_Z,0) = 0.000000; -NODES[384](VELOCITY_X,0) = 0.000000; -NODES[384](VELOCITY_Y,0) = 0.000000; -NODES[384](VELOCITY_Z,0) = 0.000000; -NODES[385](VELOCITY_X,0) = 0.000000; -NODES[385](VELOCITY_Y,0) = 0.000000; -NODES[385](VELOCITY_Z,0) = 0.000000; -NODES[386](VELOCITY_X,0) = 0.000000; -NODES[386](VELOCITY_Y,0) = 0.000000; -NODES[386](VELOCITY_Z,0) = 0.000000; -NODES[387](VELOCITY_X,0) = 0.000000; -NODES[387](VELOCITY_Y,0) = 0.000000; -NODES[387](VELOCITY_Z,0) = 0.000000; -NODES[388](VELOCITY_X,0) = 0.000000; -NODES[388](VELOCITY_Y,0) = 0.000000; -NODES[388](VELOCITY_Z,0) = 0.000000; -NODES[389](VELOCITY_X,0) = 0.000000; -NODES[389](VELOCITY_Y,0) = 0.000000; -NODES[389](VELOCITY_Z,0) = 0.000000; -NODES[390](VELOCITY_X,0) = 0.000000; -NODES[390](VELOCITY_Y,0) = 0.000000; -NODES[390](VELOCITY_Z,0) = 0.000000; -NODES[391](VELOCITY_X,0) = 0.000000; -NODES[391](VELOCITY_Y,0) = 0.000000; -NODES[391](VELOCITY_Z,0) = 0.000000; -NODES[392](VELOCITY_X,0) = 0.000000; -NODES[392](VELOCITY_Y,0) = 0.000000; -NODES[392](VELOCITY_Z,0) = 0.000000; -NODES[393](VELOCITY_X,0) = 0.000000; -NODES[393](VELOCITY_Y,0) = 0.000000; -NODES[393](VELOCITY_Z,0) = 0.000000; -NODES[394](VELOCITY_X,0) = 0.000000; -NODES[394](VELOCITY_Y,0) = 0.000000; -NODES[394](VELOCITY_Z,0) = 0.000000; -NODES[395](VELOCITY_X,0) = 0.000000; -NODES[395](VELOCITY_Y,0) = 0.000000; -NODES[395](VELOCITY_Z,0) = 0.000000; -NODES[396](VELOCITY_X,0) = 0.000000; -NODES[396](VELOCITY_Y,0) = 0.000000; -NODES[396](VELOCITY_Z,0) = 0.000000; -NODES[397](VELOCITY_X,0) = 0.000000; -NODES[397](VELOCITY_Y,0) = 0.000000; -NODES[397](VELOCITY_Z,0) = 0.000000; -NODES[398](VELOCITY_X,0) = 0.000000; -NODES[398](VELOCITY_Y,0) = 0.000000; -NODES[398](VELOCITY_Z,0) = 0.000000; -NODES[399](VELOCITY_X,0) = 0.000000; -NODES[399](VELOCITY_Y,0) = 0.000000; -NODES[399](VELOCITY_Z,0) = 0.000000; -NODES[400](VELOCITY_X,0) = 0.000000; -NODES[400](VELOCITY_Y,0) = 0.000000; -NODES[400](VELOCITY_Z,0) = 0.000000; -NODES[401](VELOCITY_X,0) = 0.000000; -NODES[401](VELOCITY_Y,0) = 0.000000; -NODES[401](VELOCITY_Z,0) = 0.000000; -NODES[402](VELOCITY_X,0) = 0.000000; -NODES[402](VELOCITY_Y,0) = 0.000000; -NODES[402](VELOCITY_Z,0) = 0.000000; -NODES[403](VELOCITY_X,0) = 0.000000; -NODES[403](VELOCITY_Y,0) = 0.000000; -NODES[403](VELOCITY_Z,0) = 0.000000; -NODES[404](VELOCITY_X,0) = 0.000000; -NODES[404](VELOCITY_Y,0) = 0.000000; -NODES[404](VELOCITY_Z,0) = 0.000000; -NODES[405](VELOCITY_X,0) = 0.000000; -NODES[405](VELOCITY_Y,0) = 0.000000; -NODES[405](VELOCITY_Z,0) = 0.000000; -NODES[406](VELOCITY_X,0) = 0.000000; -NODES[406](VELOCITY_Y,0) = 0.000000; -NODES[406](VELOCITY_Z,0) = 0.000000; -NODES[407](VELOCITY_X,0) = 0.000000; -NODES[407](VELOCITY_Y,0) = 0.000000; -NODES[407](VELOCITY_Z,0) = 0.000000; -NODES[408](VELOCITY_X,0) = 0.000000; -NODES[408](VELOCITY_Y,0) = 0.000000; -NODES[408](VELOCITY_Z,0) = 0.000000; -NODES[409](VELOCITY_X,0) = 0.000000; -NODES[409](VELOCITY_Y,0) = 0.000000; -NODES[409](VELOCITY_Z,0) = 0.000000; -NODES[410](VELOCITY_X,0) = 0.000000; -NODES[410](VELOCITY_Y,0) = 0.000000; -NODES[410](VELOCITY_Z,0) = 0.000000; -NODES[411](VELOCITY_X,0) = 0.000000; -NODES[411](VELOCITY_Y,0) = 0.000000; -NODES[411](VELOCITY_Z,0) = 0.000000; -NODES[412](VELOCITY_X,0) = 0.000000; -NODES[412](VELOCITY_Y,0) = 0.000000; -NODES[412](VELOCITY_Z,0) = 0.000000; -NODES[413](VELOCITY_X,0) = 0.000000; -NODES[413](VELOCITY_Y,0) = 0.000000; -NODES[413](VELOCITY_Z,0) = 0.000000; -NODES[414](VELOCITY_X,0) = 0.000000; -NODES[414](VELOCITY_Y,0) = 0.000000; -NODES[414](VELOCITY_Z,0) = 0.000000; -NODES[415](VELOCITY_X,0) = 0.000000; -NODES[415](VELOCITY_Y,0) = 0.000000; -NODES[415](VELOCITY_Z,0) = 0.000000; -NODES[416](VELOCITY_X,0) = 0.000000; -NODES[416](VELOCITY_Y,0) = 0.000000; -NODES[416](VELOCITY_Z,0) = 0.000000; -NODES[417](VELOCITY_X,0) = 0.000000; -NODES[417](VELOCITY_Y,0) = 0.000000; -NODES[417](VELOCITY_Z,0) = 0.000000; -NODES[418](VELOCITY_X,0) = 0.000000; -NODES[418](VELOCITY_Y,0) = 0.000000; -NODES[418](VELOCITY_Z,0) = 0.000000; -NODES[419](VELOCITY_X,0) = 0.000000; -NODES[419](VELOCITY_Y,0) = 0.000000; -NODES[419](VELOCITY_Z,0) = 0.000000; -NODES[420](VELOCITY_X,0) = 0.000000; -NODES[420](VELOCITY_Y,0) = 0.000000; -NODES[420](VELOCITY_Z,0) = 0.000000; -NODES[421](VELOCITY_X,0) = 0.000000; -NODES[421](VELOCITY_Y,0) = 0.000000; -NODES[421](VELOCITY_Z,0) = 0.000000; -NODES[422](VELOCITY_X,0) = 0.000000; -NODES[422](VELOCITY_Y,0) = 0.000000; -NODES[422](VELOCITY_Z,0) = 0.000000; -NODES[423](VELOCITY_X,0) = 0.000000; -NODES[423](VELOCITY_Y,0) = 0.000000; -NODES[423](VELOCITY_Z,0) = 0.000000; -NODES[424](VELOCITY_X,0) = 0.000000; -NODES[424](VELOCITY_Y,0) = 0.000000; -NODES[424](VELOCITY_Z,0) = 0.000000; -NODES[425](VELOCITY_X,0) = 0.000000; -NODES[425](VELOCITY_Y,0) = 0.000000; -NODES[425](VELOCITY_Z,0) = 0.000000; -NODES[426](VELOCITY_X,0) = 0.000000; -NODES[426](VELOCITY_Y,0) = 0.000000; -NODES[426](VELOCITY_Z,0) = 0.000000; -NODES[427](VELOCITY_X,0) = 0.000000; -NODES[427](VELOCITY_Y,0) = 0.000000; -NODES[427](VELOCITY_Z,0) = 0.000000; -NODES[428](VELOCITY_X,0) = 0.000000; -NODES[428](VELOCITY_Y,0) = 0.000000; -NODES[428](VELOCITY_Z,0) = 0.000000; -NODES[429](VELOCITY_X,0) = 0.000000; -NODES[429](VELOCITY_Y,0) = 0.000000; -NODES[429](VELOCITY_Z,0) = 0.000000; -NODES[430](VELOCITY_X,0) = 0.000000; -NODES[430](VELOCITY_Y,0) = 0.000000; -NODES[430](VELOCITY_Z,0) = 0.000000; -NODES[431](VELOCITY_X,0) = 0.000000; -NODES[431](VELOCITY_Y,0) = 0.000000; -NODES[431](VELOCITY_Z,0) = 0.000000; -NODES[432](VELOCITY_X,0) = 0.000000; -NODES[432](VELOCITY_Y,0) = 0.000000; -NODES[432](VELOCITY_Z,0) = 0.000000; -NODES[433](VELOCITY_X,0) = 0.000000; -NODES[433](VELOCITY_Y,0) = 0.000000; -NODES[433](VELOCITY_Z,0) = 0.000000; -NODES[434](VELOCITY_X,0) = 0.000000; -NODES[434](VELOCITY_Y,0) = 0.000000; -NODES[434](VELOCITY_Z,0) = 0.000000; -NODES[435](VELOCITY_X,0) = 0.000000; -NODES[435](VELOCITY_Y,0) = 0.000000; -NODES[435](VELOCITY_Z,0) = 0.000000; -NODES[436](VELOCITY_X,0) = 0.000000; -NODES[436](VELOCITY_Y,0) = 0.000000; -NODES[436](VELOCITY_Z,0) = 0.000000; -NODES[437](VELOCITY_X,0) = 0.000000; -NODES[437](VELOCITY_Y,0) = 0.000000; -NODES[437](VELOCITY_Z,0) = 0.000000; -NODES[438](VELOCITY_X,0) = 0.000000; -NODES[438](VELOCITY_Y,0) = 0.000000; -NODES[438](VELOCITY_Z,0) = 0.000000; -NODES[439](VELOCITY_X,0) = 0.000000; -NODES[439](VELOCITY_Y,0) = 0.000000; -NODES[439](VELOCITY_Z,0) = 0.000000; -NODES[440](VELOCITY_X,0) = 0.000000; -NODES[440](VELOCITY_Y,0) = 0.000000; -NODES[440](VELOCITY_Z,0) = 0.000000; -NODES[441](VELOCITY_X,0) = 0.000000; -NODES[441](VELOCITY_Y,0) = 0.000000; -NODES[441](VELOCITY_Z,0) = 0.000000; -NODES[442](VELOCITY_X,0) = 0.000000; -NODES[442](VELOCITY_Y,0) = 0.000000; -NODES[442](VELOCITY_Z,0) = 0.000000; -NODES[443](VELOCITY_X,0) = 0.000000; -NODES[443](VELOCITY_Y,0) = 0.000000; -NODES[443](VELOCITY_Z,0) = 0.000000; -NODES[444](VELOCITY_X,0) = 0.000000; -NODES[444](VELOCITY_Y,0) = 0.000000; -NODES[444](VELOCITY_Z,0) = 0.000000; -NODES[445](VELOCITY_X,0) = 0.000000; -NODES[445](VELOCITY_Y,0) = 0.000000; -NODES[445](VELOCITY_Z,0) = 0.000000; -NODES[446](VELOCITY_X,0) = 0.000000; -NODES[446](VELOCITY_Y,0) = 0.000000; -NODES[446](VELOCITY_Z,0) = 0.000000; -NODES[447](VELOCITY_X,0) = 0.000000; -NODES[447](VELOCITY_Y,0) = 0.000000; -NODES[447](VELOCITY_Z,0) = 0.000000; -NODES[448](VELOCITY_X,0) = 0.000000; -NODES[448](VELOCITY_Y,0) = 0.000000; -NODES[448](VELOCITY_Z,0) = 0.000000; -NODES[449](VELOCITY_X,0) = 0.000000; -NODES[449](VELOCITY_Y,0) = 0.000000; -NODES[449](VELOCITY_Z,0) = 0.000000; -NODES[450](VELOCITY_X,0) = 0.000000; -NODES[450](VELOCITY_Y,0) = 0.000000; -NODES[450](VELOCITY_Z,0) = 0.000000; -NODES[451](VELOCITY_X,0) = 0.000000; -NODES[451](VELOCITY_Y,0) = 0.000000; -NODES[451](VELOCITY_Z,0) = 0.000000; -NODES[452](VELOCITY_X,0) = 0.000000; -NODES[452](VELOCITY_Y,0) = 0.000000; -NODES[452](VELOCITY_Z,0) = 0.000000; -NODES[453](VELOCITY_X,0) = 0.000000; -NODES[453](VELOCITY_Y,0) = 0.000000; -NODES[453](VELOCITY_Z,0) = 0.000000; -NODES[454](VELOCITY_X,0) = 0.000000; -NODES[454](VELOCITY_Y,0) = 0.000000; -NODES[454](VELOCITY_Z,0) = 0.000000; -NODES[455](VELOCITY_X,0) = 0.000000; -NODES[455](VELOCITY_Y,0) = 0.000000; -NODES[455](VELOCITY_Z,0) = 0.000000; -NODES[456](VELOCITY_X,0) = 0.000000; -NODES[456](VELOCITY_Y,0) = 0.000000; -NODES[456](VELOCITY_Z,0) = 0.000000; -NODES[457](VELOCITY_X,0) = 0.000000; -NODES[457](VELOCITY_Y,0) = 0.000000; -NODES[457](VELOCITY_Z,0) = 0.000000; -NODES[458](VELOCITY_X,0) = 0.000000; -NODES[458](VELOCITY_Y,0) = 0.000000; -NODES[458](VELOCITY_Z,0) = 0.000000; -NODES[459](VELOCITY_X,0) = 0.000000; -NODES[459](VELOCITY_Y,0) = 0.000000; -NODES[459](VELOCITY_Z,0) = 0.000000; -NODES[460](VELOCITY_X,0) = 0.000000; -NODES[460](VELOCITY_Y,0) = 0.000000; -NODES[460](VELOCITY_Z,0) = 0.000000; -NODES[461](VELOCITY_X,0) = 0.000000; -NODES[461](VELOCITY_Y,0) = 0.000000; -NODES[461](VELOCITY_Z,0) = 0.000000; -NODES[462](VELOCITY_X,0) = 0.000000; -NODES[462](VELOCITY_Y,0) = 0.000000; -NODES[462](VELOCITY_Z,0) = 0.000000; -NODES[463](VELOCITY_X,0) = 0.000000; -NODES[463](VELOCITY_Y,0) = 0.000000; -NODES[463](VELOCITY_Z,0) = 0.000000; -NODES[464](VELOCITY_X,0) = 0.000000; -NODES[464](VELOCITY_Y,0) = 0.000000; -NODES[464](VELOCITY_Z,0) = 0.000000; -NODES[465](VELOCITY_X,0) = 0.000000; -NODES[465](VELOCITY_Y,0) = 0.000000; -NODES[465](VELOCITY_Z,0) = 0.000000; -NODES[466](VELOCITY_X,0) = 0.000000; -NODES[466](VELOCITY_Y,0) = 0.000000; -NODES[466](VELOCITY_Z,0) = 0.000000; -NODES[467](VELOCITY_X,0) = 0.000000; -NODES[467](VELOCITY_Y,0) = 0.000000; -NODES[467](VELOCITY_Z,0) = 0.000000; -NODES[468](VELOCITY_X,0) = 0.000000; -NODES[468](VELOCITY_Y,0) = 0.000000; -NODES[468](VELOCITY_Z,0) = 0.000000; -NODES[469](VELOCITY_X,0) = 0.000000; -NODES[469](VELOCITY_Y,0) = 0.000000; -NODES[469](VELOCITY_Z,0) = 0.000000; -NODES[470](VELOCITY_X,0) = 0.000000; -NODES[470](VELOCITY_Y,0) = 0.000000; -NODES[470](VELOCITY_Z,0) = 0.000000; -NODES[471](VELOCITY_X,0) = 0.000000; -NODES[471](VELOCITY_Y,0) = 0.000000; -NODES[471](VELOCITY_Z,0) = 0.000000; -NODES[472](VELOCITY_X,0) = 0.000000; -NODES[472](VELOCITY_Y,0) = 0.000000; -NODES[472](VELOCITY_Z,0) = 0.000000; -NODES[473](VELOCITY_X,0) = 0.000000; -NODES[473](VELOCITY_Y,0) = 0.000000; -NODES[473](VELOCITY_Z,0) = 0.000000; -NODES[474](VELOCITY_X,0) = 0.000000; -NODES[474](VELOCITY_Y,0) = 0.000000; -NODES[474](VELOCITY_Z,0) = 0.000000; -NODES[475](VELOCITY_X,0) = 0.000000; -NODES[475](VELOCITY_Y,0) = 0.000000; -NODES[475](VELOCITY_Z,0) = 0.000000; -NODES[476](VELOCITY_X,0) = 0.000000; -NODES[476](VELOCITY_Y,0) = 0.000000; -NODES[476](VELOCITY_Z,0) = 0.000000; -NODES[477](VELOCITY_X,0) = 0.000000; -NODES[477](VELOCITY_Y,0) = 0.000000; -NODES[477](VELOCITY_Z,0) = 0.000000; -NODES[478](VELOCITY_X,0) = 0.000000; -NODES[478](VELOCITY_Y,0) = 0.000000; -NODES[478](VELOCITY_Z,0) = 0.000000; -NODES[479](VELOCITY_X,0) = 0.000000; -NODES[479](VELOCITY_Y,0) = 0.000000; -NODES[479](VELOCITY_Z,0) = 0.000000; -NODES[480](VELOCITY_X,0) = 0.000000; -NODES[480](VELOCITY_Y,0) = 0.000000; -NODES[480](VELOCITY_Z,0) = 0.000000; -NODES[481](VELOCITY_X,0) = 0.000000; -NODES[481](VELOCITY_Y,0) = 0.000000; -NODES[481](VELOCITY_Z,0) = 0.000000; -NODES[482](VELOCITY_X,0) = 0.000000; -NODES[482](VELOCITY_Y,0) = 0.000000; -NODES[482](VELOCITY_Z,0) = 0.000000; -NODES[483](VELOCITY_X,0) = 0.000000; -NODES[483](VELOCITY_Y,0) = 0.000000; -NODES[483](VELOCITY_Z,0) = 0.000000; -NODES[484](VELOCITY_X,0) = 0.000000; -NODES[484](VELOCITY_Y,0) = 0.000000; -NODES[484](VELOCITY_Z,0) = 0.000000; -NODES[485](VELOCITY_X,0) = 0.000000; -NODES[485](VELOCITY_Y,0) = 0.000000; -NODES[485](VELOCITY_Z,0) = 0.000000; -NODES[486](VELOCITY_X,0) = 0.000000; -NODES[486](VELOCITY_Y,0) = 0.000000; -NODES[486](VELOCITY_Z,0) = 0.000000; -NODES[487](VELOCITY_X,0) = 0.000000; -NODES[487](VELOCITY_Y,0) = 0.000000; -NODES[487](VELOCITY_Z,0) = 0.000000; -NODES[488](VELOCITY_X,0) = 0.000000; -NODES[488](VELOCITY_Y,0) = 0.000000; -NODES[488](VELOCITY_Z,0) = 0.000000; -NODES[489](VELOCITY_X,0) = 0.000000; -NODES[489](VELOCITY_Y,0) = 0.000000; -NODES[489](VELOCITY_Z,0) = 0.000000; -NODES[490](VELOCITY_X,0) = 0.000000; -NODES[490](VELOCITY_Y,0) = 0.000000; -NODES[490](VELOCITY_Z,0) = 0.000000; -NODES[491](VELOCITY_X,0) = 0.000000; -NODES[491](VELOCITY_Y,0) = 0.000000; -NODES[491](VELOCITY_Z,0) = 0.000000; -NODES[492](VELOCITY_X,0) = 0.000000; -NODES[492](VELOCITY_Y,0) = 0.000000; -NODES[492](VELOCITY_Z,0) = 0.000000; -NODES[493](VELOCITY_X,0) = 0.000000; -NODES[493](VELOCITY_Y,0) = 0.000000; -NODES[493](VELOCITY_Z,0) = 0.000000; -NODES[494](VELOCITY_X,0) = 0.000000; -NODES[494](VELOCITY_Y,0) = 0.000000; -NODES[494](VELOCITY_Z,0) = 0.000000; -NODES[495](VELOCITY_X,0) = 0.000000; -NODES[495](VELOCITY_Y,0) = 0.000000; -NODES[495](VELOCITY_Z,0) = 0.000000; -NODES[496](VELOCITY_X,0) = 0.000000; -NODES[496](VELOCITY_Y,0) = 0.000000; -NODES[496](VELOCITY_Z,0) = 0.000000; -NODES[497](VELOCITY_X,0) = 0.000000; -NODES[497](VELOCITY_Y,0) = 0.000000; -NODES[497](VELOCITY_Z,0) = 0.000000; -NODES[498](VELOCITY_X,0) = 0.000000; -NODES[498](VELOCITY_Y,0) = 0.000000; -NODES[498](VELOCITY_Z,0) = 0.000000; -NODES[499](VELOCITY_X,0) = 0.000000; -NODES[499](VELOCITY_Y,0) = 0.000000; -NODES[499](VELOCITY_Z,0) = 0.000000; -NODES[500](VELOCITY_X,0) = 0.000000; -NODES[500](VELOCITY_Y,0) = 0.000000; -NODES[500](VELOCITY_Z,0) = 0.000000; -NODES[501](VELOCITY_X,0) = 0.000000; -NODES[501](VELOCITY_Y,0) = 0.000000; -NODES[501](VELOCITY_Z,0) = 0.000000; -NODES[502](VELOCITY_X,0) = 0.000000; -NODES[502](VELOCITY_Y,0) = 0.000000; -NODES[502](VELOCITY_Z,0) = 0.000000; -NODES[503](VELOCITY_X,0) = 0.000000; -NODES[503](VELOCITY_Y,0) = 0.000000; -NODES[503](VELOCITY_Z,0) = 0.000000; -NODES[504](VELOCITY_X,0) = 0.000000; -NODES[504](VELOCITY_Y,0) = 0.000000; -NODES[504](VELOCITY_Z,0) = 0.000000; -NODES[505](VELOCITY_X,0) = 0.000000; -NODES[505](VELOCITY_Y,0) = 0.000000; -NODES[505](VELOCITY_Z,0) = 0.000000; -NODES[506](VELOCITY_X,0) = 0.000000; -NODES[506](VELOCITY_Y,0) = 0.000000; -NODES[506](VELOCITY_Z,0) = 0.000000; -NODES[507](VELOCITY_X,0) = 0.000000; -NODES[507](VELOCITY_Y,0) = 0.000000; -NODES[507](VELOCITY_Z,0) = 0.000000; -NODES[508](VELOCITY_X,0) = 0.000000; -NODES[508](VELOCITY_Y,0) = 0.000000; -NODES[508](VELOCITY_Z,0) = 0.000000; -NODES[509](VELOCITY_X,0) = 0.000000; -NODES[509](VELOCITY_Y,0) = 0.000000; -NODES[509](VELOCITY_Z,0) = 0.000000; -NODES[510](VELOCITY_X,0) = 0.000000; -NODES[510](VELOCITY_Y,0) = 0.000000; -NODES[510](VELOCITY_Z,0) = 0.000000; -NODES[511](VELOCITY_X,0) = 0.000000; -NODES[511](VELOCITY_Y,0) = 0.000000; -NODES[511](VELOCITY_Z,0) = 0.000000; -NODES[512](VELOCITY_X,0) = 0.000000; -NODES[512](VELOCITY_Y,0) = 0.000000; -NODES[512](VELOCITY_Z,0) = 0.000000; -NODES[513](VELOCITY_X,0) = 0.000000; -NODES[513](VELOCITY_Y,0) = 0.000000; -NODES[513](VELOCITY_Z,0) = 0.000000; -NODES[514](VELOCITY_X,0) = 0.000000; -NODES[514](VELOCITY_Y,0) = 0.000000; -NODES[514](VELOCITY_Z,0) = 0.000000; -NODES[515](VELOCITY_X,0) = 0.000000; -NODES[515](VELOCITY_Y,0) = 0.000000; -NODES[515](VELOCITY_Z,0) = 0.000000; -NODES[516](VELOCITY_X,0) = 0.000000; -NODES[516](VELOCITY_Y,0) = 0.000000; -NODES[516](VELOCITY_Z,0) = 0.000000; -NODES[517](VELOCITY_X,0) = 0.000000; -NODES[517](VELOCITY_Y,0) = 0.000000; -NODES[517](VELOCITY_Z,0) = 0.000000; -NODES[518](VELOCITY_X,0) = 0.000000; -NODES[518](VELOCITY_Y,0) = 0.000000; -NODES[518](VELOCITY_Z,0) = 0.000000; -NODES[519](VELOCITY_X,0) = 0.000000; -NODES[519](VELOCITY_Y,0) = 0.000000; -NODES[519](VELOCITY_Z,0) = 0.000000; -NODES[520](VELOCITY_X,0) = 0.000000; -NODES[520](VELOCITY_Y,0) = 0.000000; -NODES[520](VELOCITY_Z,0) = 0.000000; -NODES[521](VELOCITY_X,0) = 0.000000; -NODES[521](VELOCITY_Y,0) = 0.000000; -NODES[521](VELOCITY_Z,0) = 0.000000; -NODES[522](VELOCITY_X,0) = 0.000000; -NODES[522](VELOCITY_Y,0) = 0.000000; -NODES[522](VELOCITY_Z,0) = 0.000000; -NODES[523](VELOCITY_X,0) = 0.000000; -NODES[523](VELOCITY_Y,0) = 0.000000; -NODES[523](VELOCITY_Z,0) = 0.000000; -NODES[524](VELOCITY_X,0) = 0.000000; -NODES[524](VELOCITY_Y,0) = 0.000000; -NODES[524](VELOCITY_Z,0) = 0.000000; -NODES[525](VELOCITY_X,0) = 0.000000; -NODES[525](VELOCITY_Y,0) = 0.000000; -NODES[525](VELOCITY_Z,0) = 0.000000; -NODES[526](VELOCITY_X,0) = 0.000000; -NODES[526](VELOCITY_Y,0) = 0.000000; -NODES[526](VELOCITY_Z,0) = 0.000000; -NODES[527](VELOCITY_X,0) = 0.000000; -NODES[527](VELOCITY_Y,0) = 0.000000; -NODES[527](VELOCITY_Z,0) = 0.000000; -NODES[528](VELOCITY_X,0) = 0.000000; -NODES[528](VELOCITY_Y,0) = 0.000000; -NODES[528](VELOCITY_Z,0) = 0.000000; -NODES[529](VELOCITY_X,0) = 0.000000; -NODES[529](VELOCITY_Y,0) = 0.000000; -NODES[529](VELOCITY_Z,0) = 0.000000; -NODES[530](VELOCITY_X,0) = 0.000000; -NODES[530](VELOCITY_Y,0) = 0.000000; -NODES[530](VELOCITY_Z,0) = 0.000000; -NODES[531](VELOCITY_X,0) = 0.000000; -NODES[531](VELOCITY_Y,0) = 0.000000; -NODES[531](VELOCITY_Z,0) = 0.000000; -NODES[532](VELOCITY_X,0) = 0.000000; -NODES[532](VELOCITY_Y,0) = 0.000000; -NODES[532](VELOCITY_Z,0) = 0.000000; -NODES[533](VELOCITY_X,0) = 0.000000; -NODES[533](VELOCITY_Y,0) = 0.000000; -NODES[533](VELOCITY_Z,0) = 0.000000; -NODES[534](VELOCITY_X,0) = 0.000000; -NODES[534](VELOCITY_Y,0) = 0.000000; -NODES[534](VELOCITY_Z,0) = 0.000000; -NODES[535](VELOCITY_X,0) = 0.000000; -NODES[535](VELOCITY_Y,0) = 0.000000; -NODES[535](VELOCITY_Z,0) = 0.000000; -NODES[536](VELOCITY_X,0) = 0.000000; -NODES[536](VELOCITY_Y,0) = 0.000000; -NODES[536](VELOCITY_Z,0) = 0.000000; -NODES[537](VELOCITY_X,0) = 0.000000; -NODES[537](VELOCITY_Y,0) = 0.000000; -NODES[537](VELOCITY_Z,0) = 0.000000; -NODES[538](VELOCITY_X,0) = 0.000000; -NODES[538](VELOCITY_Y,0) = 0.000000; -NODES[538](VELOCITY_Z,0) = 0.000000; -NODES[539](VELOCITY_X,0) = 0.000000; -NODES[539](VELOCITY_Y,0) = 0.000000; -NODES[539](VELOCITY_Z,0) = 0.000000; -NODES[540](VELOCITY_X,0) = 0.000000; -NODES[540](VELOCITY_Y,0) = 0.000000; -NODES[540](VELOCITY_Z,0) = 0.000000; -NODES[541](VELOCITY_X,0) = 0.000000; -NODES[541](VELOCITY_Y,0) = 0.000000; -NODES[541](VELOCITY_Z,0) = 0.000000; -NODES[542](VELOCITY_X,0) = 0.000000; -NODES[542](VELOCITY_Y,0) = 0.000000; -NODES[542](VELOCITY_Z,0) = 0.000000; -NODES[543](VELOCITY_X,0) = 0.000000; -NODES[543](VELOCITY_Y,0) = 0.000000; -NODES[543](VELOCITY_Z,0) = 0.000000; -NODES[544](VELOCITY_X,0) = 0.000000; -NODES[544](VELOCITY_Y,0) = 0.000000; -NODES[544](VELOCITY_Z,0) = 0.000000; -NODES[545](VELOCITY_X,0) = 0.000000; -NODES[545](VELOCITY_Y,0) = 0.000000; -NODES[545](VELOCITY_Z,0) = 0.000000; -NODES[546](VELOCITY_X,0) = 0.000000; -NODES[546](VELOCITY_Y,0) = 0.000000; -NODES[546](VELOCITY_Z,0) = 0.000000; -NODES[547](VELOCITY_X,0) = 0.000000; -NODES[547](VELOCITY_Y,0) = 0.000000; -NODES[547](VELOCITY_Z,0) = 0.000000; -NODES[548](VELOCITY_X,0) = 0.000000; -NODES[548](VELOCITY_Y,0) = 0.000000; -NODES[548](VELOCITY_Z,0) = 0.000000; -NODES[549](VELOCITY_X,0) = 0.000000; -NODES[549](VELOCITY_Y,0) = 0.000000; -NODES[549](VELOCITY_Z,0) = 0.000000; -NODES[550](VELOCITY_X,0) = 0.000000; -NODES[550](VELOCITY_Y,0) = 0.000000; -NODES[550](VELOCITY_Z,0) = 0.000000; -NODES[551](VELOCITY_X,0) = 0.000000; -NODES[551](VELOCITY_Y,0) = 0.000000; -NODES[551](VELOCITY_Z,0) = 0.000000; -NODES[552](VELOCITY_X,0) = 0.000000; -NODES[552](VELOCITY_Y,0) = 0.000000; -NODES[552](VELOCITY_Z,0) = 0.000000; -NODES[553](VELOCITY_X,0) = 0.000000; -NODES[553](VELOCITY_Y,0) = 0.000000; -NODES[553](VELOCITY_Z,0) = 0.000000; -NODES[554](VELOCITY_X,0) = 0.000000; -NODES[554](VELOCITY_Y,0) = 0.000000; -NODES[554](VELOCITY_Z,0) = 0.000000; -NODES[555](VELOCITY_X,0) = 0.000000; -NODES[555](VELOCITY_Y,0) = 0.000000; -NODES[555](VELOCITY_Z,0) = 0.000000; -NODES[556](VELOCITY_X,0) = 0.000000; -NODES[556](VELOCITY_Y,0) = 0.000000; -NODES[556](VELOCITY_Z,0) = 0.000000; -NODES[557](VELOCITY_X,0) = 0.000000; -NODES[557](VELOCITY_Y,0) = 0.000000; -NODES[557](VELOCITY_Z,0) = 0.000000; -NODES[558](VELOCITY_X,0) = 0.000000; -NODES[558](VELOCITY_Y,0) = 0.000000; -NODES[558](VELOCITY_Z,0) = 0.000000; -NODES[559](VELOCITY_X,0) = 0.000000; -NODES[559](VELOCITY_Y,0) = 0.000000; -NODES[559](VELOCITY_Z,0) = 0.000000; -NODES[560](VELOCITY_X,0) = 0.000000; -NODES[560](VELOCITY_Y,0) = 0.000000; -NODES[560](VELOCITY_Z,0) = 0.000000; -NODES[561](VELOCITY_X,0) = 0.000000; -NODES[561](VELOCITY_Y,0) = 0.000000; -NODES[561](VELOCITY_Z,0) = 0.000000; -NODES[562](VELOCITY_X,0) = 0.000000; -NODES[562](VELOCITY_Y,0) = 0.000000; -NODES[562](VELOCITY_Z,0) = 0.000000; -NODES[563](VELOCITY_X,0) = 0.000000; -NODES[563](VELOCITY_Y,0) = 0.000000; -NODES[563](VELOCITY_Z,0) = 0.000000; -NODES[564](VELOCITY_X,0) = 0.000000; -NODES[564](VELOCITY_Y,0) = 0.000000; -NODES[564](VELOCITY_Z,0) = 0.000000; -NODES[565](VELOCITY_X,0) = 0.000000; -NODES[565](VELOCITY_Y,0) = 0.000000; -NODES[565](VELOCITY_Z,0) = 0.000000; -NODES[566](VELOCITY_X,0) = 0.000000; -NODES[566](VELOCITY_Y,0) = 0.000000; -NODES[566](VELOCITY_Z,0) = 0.000000; -NODES[567](VELOCITY_X,0) = 0.000000; -NODES[567](VELOCITY_Y,0) = 0.000000; -NODES[567](VELOCITY_Z,0) = 0.000000; -NODES[568](VELOCITY_X,0) = 0.000000; -NODES[568](VELOCITY_Y,0) = 0.000000; -NODES[568](VELOCITY_Z,0) = 0.000000; -NODES[569](VELOCITY_X,0) = 0.000000; -NODES[569](VELOCITY_Y,0) = 0.000000; -NODES[569](VELOCITY_Z,0) = 0.000000; -NODES[570](VELOCITY_X,0) = 0.000000; -NODES[570](VELOCITY_Y,0) = 0.000000; -NODES[570](VELOCITY_Z,0) = 0.000000; -NODES[571](VELOCITY_X,0) = 0.000000; -NODES[571](VELOCITY_Y,0) = 0.000000; -NODES[571](VELOCITY_Z,0) = 0.000000; -NODES[572](VELOCITY_X,0) = 0.000000; -NODES[572](VELOCITY_Y,0) = 0.000000; -NODES[572](VELOCITY_Z,0) = 0.000000; -NODES[573](VELOCITY_X,0) = 0.000000; -NODES[573](VELOCITY_Y,0) = 0.000000; -NODES[573](VELOCITY_Z,0) = 0.000000; -NODES[574](VELOCITY_X,0) = 0.000000; -NODES[574](VELOCITY_Y,0) = 0.000000; -NODES[574](VELOCITY_Z,0) = 0.000000; -NODES[575](VELOCITY_X,0) = 0.000000; -NODES[575](VELOCITY_Y,0) = 0.000000; -NODES[575](VELOCITY_Z,0) = 0.000000; -NODES[576](VELOCITY_X,0) = 0.000000; -NODES[576](VELOCITY_Y,0) = 0.000000; -NODES[576](VELOCITY_Z,0) = 0.000000; -NODES[577](VELOCITY_X,0) = 0.000000; -NODES[577](VELOCITY_Y,0) = 0.000000; -NODES[577](VELOCITY_Z,0) = 0.000000; -NODES[578](VELOCITY_X,0) = 0.000000; -NODES[578](VELOCITY_Y,0) = 0.000000; -NODES[578](VELOCITY_Z,0) = 0.000000; -NODES[579](VELOCITY_X,0) = 0.000000; -NODES[579](VELOCITY_Y,0) = 0.000000; -NODES[579](VELOCITY_Z,0) = 0.000000; -NODES[580](VELOCITY_X,0) = 0.000000; -NODES[580](VELOCITY_Y,0) = 0.000000; -NODES[580](VELOCITY_Z,0) = 0.000000; -NODES[581](VELOCITY_X,0) = 0.000000; -NODES[581](VELOCITY_Y,0) = 0.000000; -NODES[581](VELOCITY_Z,0) = 0.000000; -NODES[582](VELOCITY_X,0) = 0.000000; -NODES[582](VELOCITY_Y,0) = 0.000000; -NODES[582](VELOCITY_Z,0) = 0.000000; -NODES[583](VELOCITY_X,0) = 0.000000; -NODES[583](VELOCITY_Y,0) = 0.000000; -NODES[583](VELOCITY_Z,0) = 0.000000; -NODES[584](VELOCITY_X,0) = 0.000000; -NODES[584](VELOCITY_Y,0) = 0.000000; -NODES[584](VELOCITY_Z,0) = 0.000000; -NODES[585](VELOCITY_X,0) = 0.000000; -NODES[585](VELOCITY_Y,0) = 0.000000; -NODES[585](VELOCITY_Z,0) = 0.000000; -NODES[586](VELOCITY_X,0) = 0.000000; -NODES[586](VELOCITY_Y,0) = 0.000000; -NODES[586](VELOCITY_Z,0) = 0.000000; -NODES[587](VELOCITY_X,0) = 0.000000; -NODES[587](VELOCITY_Y,0) = 0.000000; -NODES[587](VELOCITY_Z,0) = 0.000000; -NODES[588](VELOCITY_X,0) = 0.000000; -NODES[588](VELOCITY_Y,0) = 0.000000; -NODES[588](VELOCITY_Z,0) = 0.000000; -NODES[589](VELOCITY_X,0) = 0.000000; -NODES[589](VELOCITY_Y,0) = 0.000000; -NODES[589](VELOCITY_Z,0) = 0.000000; -NODES[590](VELOCITY_X,0) = 0.000000; -NODES[590](VELOCITY_Y,0) = 0.000000; -NODES[590](VELOCITY_Z,0) = 0.000000; -NODES[591](VELOCITY_X,0) = 0.000000; -NODES[591](VELOCITY_Y,0) = 0.000000; -NODES[591](VELOCITY_Z,0) = 0.000000; -NODES[592](VELOCITY_X,0) = 0.000000; -NODES[592](VELOCITY_Y,0) = 0.000000; -NODES[592](VELOCITY_Z,0) = 0.000000; -NODES[593](VELOCITY_X,0) = 0.000000; -NODES[593](VELOCITY_Y,0) = 0.000000; -NODES[593](VELOCITY_Z,0) = 0.000000; -NODES[594](VELOCITY_X,0) = 0.000000; -NODES[594](VELOCITY_Y,0) = 0.000000; -NODES[594](VELOCITY_Z,0) = 0.000000; -NODES[595](VELOCITY_X,0) = 0.000000; -NODES[595](VELOCITY_Y,0) = 0.000000; -NODES[595](VELOCITY_Z,0) = 0.000000; -NODES[596](VELOCITY_X,0) = 0.000000; -NODES[596](VELOCITY_Y,0) = 0.000000; -NODES[596](VELOCITY_Z,0) = 0.000000; -NODES[597](VELOCITY_X,0) = 0.000000; -NODES[597](VELOCITY_Y,0) = 0.000000; -NODES[597](VELOCITY_Z,0) = 0.000000; -NODES[598](VELOCITY_X,0) = 0.000000; -NODES[598](VELOCITY_Y,0) = 0.000000; -NODES[598](VELOCITY_Z,0) = 0.000000; -NODES[599](VELOCITY_X,0) = 0.000000; -NODES[599](VELOCITY_Y,0) = 0.000000; -NODES[599](VELOCITY_Z,0) = 0.000000; -NODES[600](VELOCITY_X,0) = 0.000000; -NODES[600](VELOCITY_Y,0) = 0.000000; -NODES[600](VELOCITY_Z,0) = 0.000000; -NODES[601](VELOCITY_X,0) = 0.000000; -NODES[601](VELOCITY_Y,0) = 0.000000; -NODES[601](VELOCITY_Z,0) = 0.000000; -NODES[602](VELOCITY_X,0) = 0.000000; -NODES[602](VELOCITY_Y,0) = 0.000000; -NODES[602](VELOCITY_Z,0) = 0.000000; -NODES[603](VELOCITY_X,0) = 0.000000; -NODES[603](VELOCITY_Y,0) = 0.000000; -NODES[603](VELOCITY_Z,0) = 0.000000; -NODES[604](VELOCITY_X,0) = 0.000000; -NODES[604](VELOCITY_Y,0) = 0.000000; -NODES[604](VELOCITY_Z,0) = 0.000000; -NODES[605](VELOCITY_X,0) = 0.000000; -NODES[605](VELOCITY_Y,0) = 0.000000; -NODES[605](VELOCITY_Z,0) = 0.000000; -NODES[606](VELOCITY_X,0) = 0.000000; -NODES[606](VELOCITY_Y,0) = 0.000000; -NODES[606](VELOCITY_Z,0) = 0.000000; -NODES[607](VELOCITY_X,0) = 0.000000; -NODES[607](VELOCITY_Y,0) = 0.000000; -NODES[607](VELOCITY_Z,0) = 0.000000; -NODES[608](VELOCITY_X,0) = 0.000000; -NODES[608](VELOCITY_Y,0) = 0.000000; -NODES[608](VELOCITY_Z,0) = 0.000000; -NODES[609](VELOCITY_X,0) = 0.000000; -NODES[609](VELOCITY_Y,0) = 0.000000; -NODES[609](VELOCITY_Z,0) = 0.000000; -NODES[610](VELOCITY_X,0) = 0.000000; -NODES[610](VELOCITY_Y,0) = 0.000000; -NODES[610](VELOCITY_Z,0) = 0.000000; -NODES[611](VELOCITY_X,0) = 0.000000; -NODES[611](VELOCITY_Y,0) = 0.000000; -NODES[611](VELOCITY_Z,0) = 0.000000; -NODES[612](VELOCITY_X,0) = 0.000000; -NODES[612](VELOCITY_Y,0) = 0.000000; -NODES[612](VELOCITY_Z,0) = 0.000000; -NODES[613](VELOCITY_X,0) = 0.000000; -NODES[613](VELOCITY_Y,0) = 0.000000; -NODES[613](VELOCITY_Z,0) = 0.000000; -NODES[614](VELOCITY_X,0) = 0.000000; -NODES[614](VELOCITY_Y,0) = 0.000000; -NODES[614](VELOCITY_Z,0) = 0.000000; -NODES[615](VELOCITY_X,0) = 0.000000; -NODES[615](VELOCITY_Y,0) = 0.000000; -NODES[615](VELOCITY_Z,0) = 0.000000; -NODES[616](VELOCITY_X,0) = 0.000000; -NODES[616](VELOCITY_Y,0) = 0.000000; -NODES[616](VELOCITY_Z,0) = 0.000000; -NODES[617](VELOCITY_X,0) = 0.000000; -NODES[617](VELOCITY_Y,0) = 0.000000; -NODES[617](VELOCITY_Z,0) = 0.000000; -NODES[618](VELOCITY_X,0) = 0.000000; -NODES[618](VELOCITY_Y,0) = 0.000000; -NODES[618](VELOCITY_Z,0) = 0.000000; -NODES[619](VELOCITY_X,0) = 0.000000; -NODES[619](VELOCITY_Y,0) = 0.000000; -NODES[619](VELOCITY_Z,0) = 0.000000; -NODES[620](VELOCITY_X,0) = 0.000000; -NODES[620](VELOCITY_Y,0) = 0.000000; -NODES[620](VELOCITY_Z,0) = 0.000000; -NODES[621](VELOCITY_X,0) = 0.000000; -NODES[621](VELOCITY_Y,0) = 0.000000; -NODES[621](VELOCITY_Z,0) = 0.000000; -NODES[622](VELOCITY_X,0) = 0.000000; -NODES[622](VELOCITY_Y,0) = 0.000000; -NODES[622](VELOCITY_Z,0) = 0.000000; -NODES[623](VELOCITY_X,0) = 0.000000; -NODES[623](VELOCITY_Y,0) = 0.000000; -NODES[623](VELOCITY_Z,0) = 0.000000; -NODES[624](VELOCITY_X,0) = 0.000000; -NODES[624](VELOCITY_Y,0) = 0.000000; -NODES[624](VELOCITY_Z,0) = 0.000000; -NODES[625](VELOCITY_X,0) = 0.000000; -NODES[625](VELOCITY_Y,0) = 0.000000; -NODES[625](VELOCITY_Z,0) = 0.000000; -NODES[626](VELOCITY_X,0) = 0.000000; -NODES[626](VELOCITY_Y,0) = 0.000000; -NODES[626](VELOCITY_Z,0) = 0.000000; -NODES[627](VELOCITY_X,0) = 0.000000; -NODES[627](VELOCITY_Y,0) = 0.000000; -NODES[627](VELOCITY_Z,0) = 0.000000; -NODES[628](VELOCITY_X,0) = 0.000000; -NODES[628](VELOCITY_Y,0) = 0.000000; -NODES[628](VELOCITY_Z,0) = 0.000000; -NODES[629](VELOCITY_X,0) = 0.000000; -NODES[629](VELOCITY_Y,0) = 0.000000; -NODES[629](VELOCITY_Z,0) = 0.000000; -NODES[630](VELOCITY_X,0) = 0.000000; -NODES[630](VELOCITY_Y,0) = 0.000000; -NODES[630](VELOCITY_Z,0) = 0.000000; -NODES[631](VELOCITY_X,0) = 0.000000; -NODES[631](VELOCITY_Y,0) = 0.000000; -NODES[631](VELOCITY_Z,0) = 0.000000; -NODES[632](VELOCITY_X,0) = 0.000000; -NODES[632](VELOCITY_Y,0) = 0.000000; -NODES[632](VELOCITY_Z,0) = 0.000000; -NODES[633](VELOCITY_X,0) = 0.000000; -NODES[633](VELOCITY_Y,0) = 0.000000; -NODES[633](VELOCITY_Z,0) = 0.000000; -NODES[634](VELOCITY_X,0) = 0.000000; -NODES[634](VELOCITY_Y,0) = 0.000000; -NODES[634](VELOCITY_Z,0) = 0.000000; -NODES[635](VELOCITY_X,0) = 0.000000; -NODES[635](VELOCITY_Y,0) = 0.000000; -NODES[635](VELOCITY_Z,0) = 0.000000; -NODES[636](VELOCITY_X,0) = 0.000000; -NODES[636](VELOCITY_Y,0) = 0.000000; -NODES[636](VELOCITY_Z,0) = 0.000000; -NODES[637](VELOCITY_X,0) = 0.000000; -NODES[637](VELOCITY_Y,0) = 0.000000; -NODES[637](VELOCITY_Z,0) = 0.000000; -NODES[638](VELOCITY_X,0) = 0.000000; -NODES[638](VELOCITY_Y,0) = 0.000000; -NODES[638](VELOCITY_Z,0) = 0.000000; -NODES[639](VELOCITY_X,0) = 0.000000; -NODES[639](VELOCITY_Y,0) = 0.000000; -NODES[639](VELOCITY_Z,0) = 0.000000; -NODES[640](VELOCITY_X,0) = 0.000000; -NODES[640](VELOCITY_Y,0) = 0.000000; -NODES[640](VELOCITY_Z,0) = 0.000000; -NODES[641](VELOCITY_X,0) = 0.000000; -NODES[641](VELOCITY_Y,0) = 0.000000; -NODES[641](VELOCITY_Z,0) = 0.000000; -NODES[642](VELOCITY_X,0) = 0.000000; -NODES[642](VELOCITY_Y,0) = 0.000000; -NODES[642](VELOCITY_Z,0) = 0.000000; -NODES[643](VELOCITY_X,0) = 0.000000; -NODES[643](VELOCITY_Y,0) = 0.000000; -NODES[643](VELOCITY_Z,0) = 0.000000; -NODES[644](VELOCITY_X,0) = 0.000000; -NODES[644](VELOCITY_Y,0) = 0.000000; -NODES[644](VELOCITY_Z,0) = 0.000000; -NODES[645](VELOCITY_X,0) = 0.000000; -NODES[645](VELOCITY_Y,0) = 0.000000; -NODES[645](VELOCITY_Z,0) = 0.000000; -NODES[646](VELOCITY_X,0) = 0.000000; -NODES[646](VELOCITY_Y,0) = 0.000000; -NODES[646](VELOCITY_Z,0) = 0.000000; -NODES[647](VELOCITY_X,0) = 0.000000; -NODES[647](VELOCITY_Y,0) = 0.000000; -NODES[647](VELOCITY_Z,0) = 0.000000; -NODES[648](VELOCITY_X,0) = 0.000000; -NODES[648](VELOCITY_Y,0) = 0.000000; -NODES[648](VELOCITY_Z,0) = 0.000000; -NODES[649](VELOCITY_X,0) = 0.000000; -NODES[649](VELOCITY_Y,0) = 0.000000; -NODES[649](VELOCITY_Z,0) = 0.000000; -NODES[650](VELOCITY_X,0) = 0.000000; -NODES[650](VELOCITY_Y,0) = 0.000000; -NODES[650](VELOCITY_Z,0) = 0.000000; -NODES[651](VELOCITY_X,0) = 0.000000; -NODES[651](VELOCITY_Y,0) = 0.000000; -NODES[651](VELOCITY_Z,0) = 0.000000; -NODES[652](VELOCITY_X,0) = 0.000000; -NODES[652](VELOCITY_Y,0) = 0.000000; -NODES[652](VELOCITY_Z,0) = 0.000000; -NODES[653](VELOCITY_X,0) = 0.000000; -NODES[653](VELOCITY_Y,0) = 0.000000; -NODES[653](VELOCITY_Z,0) = 0.000000; -NODES[654](VELOCITY_X,0) = 0.000000; -NODES[654](VELOCITY_Y,0) = 0.000000; -NODES[654](VELOCITY_Z,0) = 0.000000; -NODES[655](VELOCITY_X,0) = 0.000000; -NODES[655](VELOCITY_Y,0) = 0.000000; -NODES[655](VELOCITY_Z,0) = 0.000000; -NODES[656](VELOCITY_X,0) = 0.000000; -NODES[656](VELOCITY_Y,0) = 0.000000; -NODES[656](VELOCITY_Z,0) = 0.000000; -NODES[657](VELOCITY_X,0) = 0.000000; -NODES[657](VELOCITY_Y,0) = 0.000000; -NODES[657](VELOCITY_Z,0) = 0.000000; -NODES[658](VELOCITY_X,0) = 0.000000; -NODES[658](VELOCITY_Y,0) = 0.000000; -NODES[658](VELOCITY_Z,0) = 0.000000; -NODES[659](VELOCITY_X,0) = 0.000000; -NODES[659](VELOCITY_Y,0) = 0.000000; -NODES[659](VELOCITY_Z,0) = 0.000000; -NODES[660](VELOCITY_X,0) = 0.000000; -NODES[660](VELOCITY_Y,0) = 0.000000; -NODES[660](VELOCITY_Z,0) = 0.000000; -NODES[661](VELOCITY_X,0) = 0.000000; -NODES[661](VELOCITY_Y,0) = 0.000000; -NODES[661](VELOCITY_Z,0) = 0.000000; -NODES[662](VELOCITY_X,0) = 0.000000; -NODES[662](VELOCITY_Y,0) = 0.000000; -NODES[662](VELOCITY_Z,0) = 0.000000; -NODES[663](VELOCITY_X,0) = 0.000000; -NODES[663](VELOCITY_Y,0) = 0.000000; -NODES[663](VELOCITY_Z,0) = 0.000000; -NODES[664](VELOCITY_X,0) = 0.000000; -NODES[664](VELOCITY_Y,0) = 0.000000; -NODES[664](VELOCITY_Z,0) = 0.000000; -NODES[665](VELOCITY_X,0) = 0.000000; -NODES[665](VELOCITY_Y,0) = 0.000000; -NODES[665](VELOCITY_Z,0) = 0.000000; -NODES[666](VELOCITY_X,0) = 0.000000; -NODES[666](VELOCITY_Y,0) = 0.000000; -NODES[666](VELOCITY_Z,0) = 0.000000; -NODES[667](VELOCITY_X,0) = 0.000000; -NODES[667](VELOCITY_Y,0) = 0.000000; -NODES[667](VELOCITY_Z,0) = 0.000000; -NODES[668](VELOCITY_X,0) = 0.000000; -NODES[668](VELOCITY_Y,0) = 0.000000; -NODES[668](VELOCITY_Z,0) = 0.000000; -NODES[669](VELOCITY_X,0) = 0.000000; -NODES[669](VELOCITY_Y,0) = 0.000000; -NODES[669](VELOCITY_Z,0) = 0.000000; -NODES[670](VELOCITY_X,0) = 0.000000; -NODES[670](VELOCITY_Y,0) = 0.000000; -NODES[670](VELOCITY_Z,0) = 0.000000; -NODES[671](VELOCITY_X,0) = 0.000000; -NODES[671](VELOCITY_Y,0) = 0.000000; -NODES[671](VELOCITY_Z,0) = 0.000000; -NODES[672](VELOCITY_X,0) = 0.000000; -NODES[672](VELOCITY_Y,0) = 0.000000; -NODES[672](VELOCITY_Z,0) = 0.000000; -NODES[673](VELOCITY_X,0) = 0.000000; -NODES[673](VELOCITY_Y,0) = 0.000000; -NODES[673](VELOCITY_Z,0) = 0.000000; -NODES[674](VELOCITY_X,0) = 0.000000; -NODES[674](VELOCITY_Y,0) = 0.000000; -NODES[674](VELOCITY_Z,0) = 0.000000; -NODES[675](VELOCITY_X,0) = 0.000000; -NODES[675](VELOCITY_Y,0) = 0.000000; -NODES[675](VELOCITY_Z,0) = 0.000000; -NODES[676](VELOCITY_X,0) = 0.000000; -NODES[676](VELOCITY_Y,0) = 0.000000; -NODES[676](VELOCITY_Z,0) = 0.000000; -NODES[677](VELOCITY_X,0) = 0.000000; -NODES[677](VELOCITY_Y,0) = 0.000000; -NODES[677](VELOCITY_Z,0) = 0.000000; -NODES[678](VELOCITY_X,0) = 0.000000; -NODES[678](VELOCITY_Y,0) = 0.000000; -NODES[678](VELOCITY_Z,0) = 0.000000; -NODES[679](VELOCITY_X,0) = 0.000000; -NODES[679](VELOCITY_Y,0) = 0.000000; -NODES[679](VELOCITY_Z,0) = 0.000000; -NODES[680](VELOCITY_X,0) = 0.000000; -NODES[680](VELOCITY_Y,0) = 0.000000; -NODES[680](VELOCITY_Z,0) = 0.000000; -NODES[681](VELOCITY_X,0) = 0.000000; -NODES[681](VELOCITY_Y,0) = 0.000000; -NODES[681](VELOCITY_Z,0) = 0.000000; -NODES[682](VELOCITY_X,0) = 0.000000; -NODES[682](VELOCITY_Y,0) = 0.000000; -NODES[682](VELOCITY_Z,0) = 0.000000; -NODES[683](VELOCITY_X,0) = 0.000000; -NODES[683](VELOCITY_Y,0) = 0.000000; -NODES[683](VELOCITY_Z,0) = 0.000000; -NODES[684](VELOCITY_X,0) = 0.000000; -NODES[684](VELOCITY_Y,0) = 0.000000; -NODES[684](VELOCITY_Z,0) = 0.000000; -NODES[685](VELOCITY_X,0) = 0.000000; -NODES[685](VELOCITY_Y,0) = 0.000000; -NODES[685](VELOCITY_Z,0) = 0.000000; -NODES[686](VELOCITY_X,0) = 0.000000; -NODES[686](VELOCITY_Y,0) = 0.000000; -NODES[686](VELOCITY_Z,0) = 0.000000; -NODES[687](VELOCITY_X,0) = 0.000000; -NODES[687](VELOCITY_Y,0) = 0.000000; -NODES[687](VELOCITY_Z,0) = 0.000000; -NODES[688](VELOCITY_X,0) = 0.000000; -NODES[688](VELOCITY_Y,0) = 0.000000; -NODES[688](VELOCITY_Z,0) = 0.000000; -NODES[689](VELOCITY_X,0) = 0.000000; -NODES[689](VELOCITY_Y,0) = 0.000000; -NODES[689](VELOCITY_Z,0) = 0.000000; -NODES[690](VELOCITY_X,0) = 0.000000; -NODES[690](VELOCITY_Y,0) = 0.000000; -NODES[690](VELOCITY_Z,0) = 0.000000; -NODES[691](VELOCITY_X,0) = 0.000000; -NODES[691](VELOCITY_Y,0) = 0.000000; -NODES[691](VELOCITY_Z,0) = 0.000000; -NODES[692](VELOCITY_X,0) = 0.000000; -NODES[692](VELOCITY_Y,0) = 0.000000; -NODES[692](VELOCITY_Z,0) = 0.000000; -NODES[693](VELOCITY_X,0) = 0.000000; -NODES[693](VELOCITY_Y,0) = 0.000000; -NODES[693](VELOCITY_Z,0) = 0.000000; -NODES[694](VELOCITY_X,0) = 0.000000; -NODES[694](VELOCITY_Y,0) = 0.000000; -NODES[694](VELOCITY_Z,0) = 0.000000; -NODES[695](VELOCITY_X,0) = 0.000000; -NODES[695](VELOCITY_Y,0) = 0.000000; -NODES[695](VELOCITY_Z,0) = 0.000000; -NODES[696](VELOCITY_X,0) = 0.000000; -NODES[696](VELOCITY_Y,0) = 0.000000; -NODES[696](VELOCITY_Z,0) = 0.000000; -NODES[697](VELOCITY_X,0) = 0.000000; -NODES[697](VELOCITY_Y,0) = 0.000000; -NODES[697](VELOCITY_Z,0) = 0.000000; -NODES[698](VELOCITY_X,0) = 0.000000; -NODES[698](VELOCITY_Y,0) = 0.000000; -NODES[698](VELOCITY_Z,0) = 0.000000; -NODES[699](VELOCITY_X,0) = 0.000000; -NODES[699](VELOCITY_Y,0) = 0.000000; -NODES[699](VELOCITY_Z,0) = 0.000000; -NODES[700](VELOCITY_X,0) = 0.000000; -NODES[700](VELOCITY_Y,0) = 0.000000; -NODES[700](VELOCITY_Z,0) = 0.000000; -NODES[701](VELOCITY_X,0) = 0.000000; -NODES[701](VELOCITY_Y,0) = 0.000000; -NODES[701](VELOCITY_Z,0) = 0.000000; -NODES[702](VELOCITY_X,0) = 0.000000; -NODES[702](VELOCITY_Y,0) = 0.000000; -NODES[702](VELOCITY_Z,0) = 0.000000; -NODES[703](VELOCITY_X,0) = 0.000000; -NODES[703](VELOCITY_Y,0) = 0.000000; -NODES[703](VELOCITY_Z,0) = 0.000000; -NODES[704](VELOCITY_X,0) = 0.000000; -NODES[704](VELOCITY_Y,0) = 0.000000; -NODES[704](VELOCITY_Z,0) = 0.000000; -NODES[705](VELOCITY_X,0) = 0.000000; -NODES[705](VELOCITY_Y,0) = 0.000000; -NODES[705](VELOCITY_Z,0) = 0.000000; -NODES[706](VELOCITY_X,0) = 0.000000; -NODES[706](VELOCITY_Y,0) = 0.000000; -NODES[706](VELOCITY_Z,0) = 0.000000; -NODES[707](VELOCITY_X,0) = 0.000000; -NODES[707](VELOCITY_Y,0) = 0.000000; -NODES[707](VELOCITY_Z,0) = 0.000000; -NODES[708](VELOCITY_X,0) = 0.000000; -NODES[708](VELOCITY_Y,0) = 0.000000; -NODES[708](VELOCITY_Z,0) = 0.000000; -NODES[709](VELOCITY_X,0) = 0.000000; -NODES[709](VELOCITY_Y,0) = 0.000000; -NODES[709](VELOCITY_Z,0) = 0.000000; -NODES[710](VELOCITY_X,0) = 0.000000; -NODES[710](VELOCITY_Y,0) = 0.000000; -NODES[710](VELOCITY_Z,0) = 0.000000; -NODES[711](VELOCITY_X,0) = 0.000000; -NODES[711](VELOCITY_Y,0) = 0.000000; -NODES[711](VELOCITY_Z,0) = 0.000000; -NODES[712](VELOCITY_X,0) = 0.000000; -NODES[712](VELOCITY_Y,0) = 0.000000; -NODES[712](VELOCITY_Z,0) = 0.000000; -NODES[713](VELOCITY_X,0) = 0.000000; -NODES[713](VELOCITY_Y,0) = 0.000000; -NODES[713](VELOCITY_Z,0) = 0.000000; -NODES[714](VELOCITY_X,0) = 0.000000; -NODES[714](VELOCITY_Y,0) = 0.000000; -NODES[714](VELOCITY_Z,0) = 0.000000; -NODES[715](VELOCITY_X,0) = 0.000000; -NODES[715](VELOCITY_Y,0) = 0.000000; -NODES[715](VELOCITY_Z,0) = 0.000000; -NODES[716](VELOCITY_X,0) = 0.000000; -NODES[716](VELOCITY_Y,0) = 0.000000; -NODES[716](VELOCITY_Z,0) = 0.000000; -NODES[717](VELOCITY_X,0) = 0.000000; -NODES[717](VELOCITY_Y,0) = 0.000000; -NODES[717](VELOCITY_Z,0) = 0.000000; -NODES[718](VELOCITY_X,0) = 0.000000; -NODES[718](VELOCITY_Y,0) = 0.000000; -NODES[718](VELOCITY_Z,0) = 0.000000; -NODES[719](VELOCITY_X,0) = 0.000000; -NODES[719](VELOCITY_Y,0) = 0.000000; -NODES[719](VELOCITY_Z,0) = 0.000000; -NODES[720](VELOCITY_X,0) = 0.000000; -NODES[720](VELOCITY_Y,0) = 0.000000; -NODES[720](VELOCITY_Z,0) = 0.000000; -NODES[721](VELOCITY_X,0) = 0.000000; -NODES[721](VELOCITY_Y,0) = 0.000000; -NODES[721](VELOCITY_Z,0) = 0.000000; -NODES[722](VELOCITY_X,0) = 0.000000; -NODES[722](VELOCITY_Y,0) = 0.000000; -NODES[722](VELOCITY_Z,0) = 0.000000; -NODES[723](VELOCITY_X,0) = 0.000000; -NODES[723](VELOCITY_Y,0) = 0.000000; -NODES[723](VELOCITY_Z,0) = 0.000000; -NODES[724](VELOCITY_X,0) = 0.000000; -NODES[724](VELOCITY_Y,0) = 0.000000; -NODES[724](VELOCITY_Z,0) = 0.000000; -NODES[725](VELOCITY_X,0) = 0.000000; -NODES[725](VELOCITY_Y,0) = 0.000000; -NODES[725](VELOCITY_Z,0) = 0.000000; -NODES[726](VELOCITY_X,0) = 0.000000; -NODES[726](VELOCITY_Y,0) = 0.000000; -NODES[726](VELOCITY_Z,0) = 0.000000; -NODES[727](VELOCITY_X,0) = 0.000000; -NODES[727](VELOCITY_Y,0) = 0.000000; -NODES[727](VELOCITY_Z,0) = 0.000000; -NODES[728](VELOCITY_X,0) = 0.000000; -NODES[728](VELOCITY_Y,0) = 0.000000; -NODES[728](VELOCITY_Z,0) = 0.000000; -NODES[729](VELOCITY_X,0) = 0.000000; -NODES[729](VELOCITY_Y,0) = 0.000000; -NODES[729](VELOCITY_Z,0) = 0.000000; -NODES[730](VELOCITY_X,0) = 0.000000; -NODES[730](VELOCITY_Y,0) = 0.000000; -NODES[730](VELOCITY_Z,0) = 0.000000; -NODES[731](VELOCITY_X,0) = 0.000000; -NODES[731](VELOCITY_Y,0) = 0.000000; -NODES[731](VELOCITY_Z,0) = 0.000000; -NODES[732](VELOCITY_X,0) = 0.000000; -NODES[732](VELOCITY_Y,0) = 0.000000; -NODES[732](VELOCITY_Z,0) = 0.000000; -NODES[733](VELOCITY_X,0) = 0.000000; -NODES[733](VELOCITY_Y,0) = 0.000000; -NODES[733](VELOCITY_Z,0) = 0.000000; -NODES[734](VELOCITY_X,0) = 0.000000; -NODES[734](VELOCITY_Y,0) = 0.000000; -NODES[734](VELOCITY_Z,0) = 0.000000; -NODES[735](VELOCITY_X,0) = 0.000000; -NODES[735](VELOCITY_Y,0) = 0.000000; -NODES[735](VELOCITY_Z,0) = 0.000000; -NODES[736](VELOCITY_X,0) = 0.000000; -NODES[736](VELOCITY_Y,0) = 0.000000; -NODES[736](VELOCITY_Z,0) = 0.000000; -NODES[737](VELOCITY_X,0) = 0.000000; -NODES[737](VELOCITY_Y,0) = 0.000000; -NODES[737](VELOCITY_Z,0) = 0.000000; -NODES[738](VELOCITY_X,0) = 0.000000; -NODES[738](VELOCITY_Y,0) = 0.000000; -NODES[738](VELOCITY_Z,0) = 0.000000; -NODES[739](VELOCITY_X,0) = 0.000000; -NODES[739](VELOCITY_Y,0) = 0.000000; -NODES[739](VELOCITY_Z,0) = 0.000000; -NODES[740](VELOCITY_X,0) = 0.000000; -NODES[740](VELOCITY_Y,0) = 0.000000; -NODES[740](VELOCITY_Z,0) = 0.000000; -NODES[741](VELOCITY_X,0) = 0.000000; -NODES[741](VELOCITY_Y,0) = 0.000000; -NODES[741](VELOCITY_Z,0) = 0.000000; -NODES[742](VELOCITY_X,0) = 0.000000; -NODES[742](VELOCITY_Y,0) = 0.000000; -NODES[742](VELOCITY_Z,0) = 0.000000; -NODES[743](VELOCITY_X,0) = 0.000000; -NODES[743](VELOCITY_Y,0) = 0.000000; -NODES[743](VELOCITY_Z,0) = 0.000000; -NODES[744](VELOCITY_X,0) = 0.000000; -NODES[744](VELOCITY_Y,0) = 0.000000; -NODES[744](VELOCITY_Z,0) = 0.000000; -NODES[745](VELOCITY_X,0) = 0.000000; -NODES[745](VELOCITY_Y,0) = 0.000000; -NODES[745](VELOCITY_Z,0) = 0.000000; -NODES[746](VELOCITY_X,0) = 0.000000; -NODES[746](VELOCITY_Y,0) = 0.000000; -NODES[746](VELOCITY_Z,0) = 0.000000; -NODES[747](VELOCITY_X,0) = 0.000000; -NODES[747](VELOCITY_Y,0) = 0.000000; -NODES[747](VELOCITY_Z,0) = 0.000000; -NODES[748](VELOCITY_X,0) = 0.000000; -NODES[748](VELOCITY_Y,0) = 0.000000; -NODES[748](VELOCITY_Z,0) = 0.000000; -NODES[749](VELOCITY_X,0) = 0.000000; -NODES[749](VELOCITY_Y,0) = 0.000000; -NODES[749](VELOCITY_Z,0) = 0.000000; -NODES[750](VELOCITY_X,0) = 0.000000; -NODES[750](VELOCITY_Y,0) = 0.000000; -NODES[750](VELOCITY_Z,0) = 0.000000; -NODES[751](VELOCITY_X,0) = 0.000000; -NODES[751](VELOCITY_Y,0) = 0.000000; -NODES[751](VELOCITY_Z,0) = 0.000000; -NODES[752](VELOCITY_X,0) = 0.000000; -NODES[752](VELOCITY_Y,0) = 0.000000; -NODES[752](VELOCITY_Z,0) = 0.000000; -NODES[753](VELOCITY_X,0) = 0.000000; -NODES[753](VELOCITY_Y,0) = 0.000000; -NODES[753](VELOCITY_Z,0) = 0.000000; -NODES[754](VELOCITY_X,0) = 0.000000; -NODES[754](VELOCITY_Y,0) = 0.000000; -NODES[754](VELOCITY_Z,0) = 0.000000; -NODES[755](VELOCITY_X,0) = 0.000000; -NODES[755](VELOCITY_Y,0) = 0.000000; -NODES[755](VELOCITY_Z,0) = 0.000000; -NODES[756](VELOCITY_X,0) = 0.000000; -NODES[756](VELOCITY_Y,0) = 0.000000; -NODES[756](VELOCITY_Z,0) = 0.000000; -NODES[757](VELOCITY_X,0) = 0.000000; -NODES[757](VELOCITY_Y,0) = 0.000000; -NODES[757](VELOCITY_Z,0) = 0.000000; -NODES[758](VELOCITY_X,0) = 0.000000; -NODES[758](VELOCITY_Y,0) = 0.000000; -NODES[758](VELOCITY_Z,0) = 0.000000; -NODES[759](VELOCITY_X,0) = 0.000000; -NODES[759](VELOCITY_Y,0) = 0.000000; -NODES[759](VELOCITY_Z,0) = 0.000000; -NODES[760](VELOCITY_X,0) = 0.000000; -NODES[760](VELOCITY_Y,0) = 0.000000; -NODES[760](VELOCITY_Z,0) = 0.000000; -NODES[761](VELOCITY_X,0) = 0.000000; -NODES[761](VELOCITY_Y,0) = 0.000000; -NODES[761](VELOCITY_Z,0) = 0.000000; -NODES[762](VELOCITY_X,0) = 0.000000; -NODES[762](VELOCITY_Y,0) = 0.000000; -NODES[762](VELOCITY_Z,0) = 0.000000; -NODES[763](VELOCITY_X,0) = 0.000000; -NODES[763](VELOCITY_Y,0) = 0.000000; -NODES[763](VELOCITY_Z,0) = 0.000000; -NODES[764](VELOCITY_X,0) = 0.000000; -NODES[764](VELOCITY_Y,0) = 0.000000; -NODES[764](VELOCITY_Z,0) = 0.000000; -NODES[765](VELOCITY_X,0) = 0.000000; -NODES[765](VELOCITY_Y,0) = 0.000000; -NODES[765](VELOCITY_Z,0) = 0.000000; -NODES[766](VELOCITY_X,0) = 0.000000; -NODES[766](VELOCITY_Y,0) = 0.000000; -NODES[766](VELOCITY_Z,0) = 0.000000; -NODES[767](VELOCITY_X,0) = 0.000000; -NODES[767](VELOCITY_Y,0) = 0.000000; -NODES[767](VELOCITY_Z,0) = 0.000000; -NODES[768](VELOCITY_X,0) = 0.000000; -NODES[768](VELOCITY_Y,0) = 0.000000; -NODES[768](VELOCITY_Z,0) = 0.000000; -NODES[769](VELOCITY_X,0) = 0.000000; -NODES[769](VELOCITY_Y,0) = 0.000000; -NODES[769](VELOCITY_Z,0) = 0.000000; -NODES[770](VELOCITY_X,0) = 0.000000; -NODES[770](VELOCITY_Y,0) = 0.000000; -NODES[770](VELOCITY_Z,0) = 0.000000; -NODES[771](VELOCITY_X,0) = 0.000000; -NODES[771](VELOCITY_Y,0) = 0.000000; -NODES[771](VELOCITY_Z,0) = 0.000000; -NODES[772](VELOCITY_X,0) = 0.000000; -NODES[772](VELOCITY_Y,0) = 0.000000; -NODES[772](VELOCITY_Z,0) = 0.000000; -NODES[773](VELOCITY_X,0) = 0.000000; -NODES[773](VELOCITY_Y,0) = 0.000000; -NODES[773](VELOCITY_Z,0) = 0.000000; -NODES[774](VELOCITY_X,0) = 0.000000; -NODES[774](VELOCITY_Y,0) = 0.000000; -NODES[774](VELOCITY_Z,0) = 0.000000; -NODES[775](VELOCITY_X,0) = 0.000000; -NODES[775](VELOCITY_Y,0) = 0.000000; -NODES[775](VELOCITY_Z,0) = 0.000000; -NODES[776](VELOCITY_X,0) = 0.000000; -NODES[776](VELOCITY_Y,0) = 0.000000; -NODES[776](VELOCITY_Z,0) = 0.000000; -NODES[777](VELOCITY_X,0) = 0.000000; -NODES[777](VELOCITY_Y,0) = 0.000000; -NODES[777](VELOCITY_Z,0) = 0.000000; -NODES[778](VELOCITY_X,0) = 0.000000; -NODES[778](VELOCITY_Y,0) = 0.000000; -NODES[778](VELOCITY_Z,0) = 0.000000; -NODES[779](VELOCITY_X,0) = 0.000000; -NODES[779](VELOCITY_Y,0) = 0.000000; -NODES[779](VELOCITY_Z,0) = 0.000000; -NODES[780](VELOCITY_X,0) = 0.000000; -NODES[780](VELOCITY_Y,0) = 0.000000; -NODES[780](VELOCITY_Z,0) = 0.000000; -NODES[781](VELOCITY_X,0) = 0.000000; -NODES[781](VELOCITY_Y,0) = 0.000000; -NODES[781](VELOCITY_Z,0) = 0.000000; -NODES[782](VELOCITY_X,0) = 0.000000; -NODES[782](VELOCITY_Y,0) = 0.000000; -NODES[782](VELOCITY_Z,0) = 0.000000; -NODES[783](VELOCITY_X,0) = 0.000000; -NODES[783](VELOCITY_Y,0) = 0.000000; -NODES[783](VELOCITY_Z,0) = 0.000000; -NODES[784](VELOCITY_X,0) = 0.000000; -NODES[784](VELOCITY_Y,0) = 0.000000; -NODES[784](VELOCITY_Z,0) = 0.000000; -NODES[785](VELOCITY_X,0) = 0.000000; -NODES[785](VELOCITY_Y,0) = 0.000000; -NODES[785](VELOCITY_Z,0) = 0.000000; -NODES[786](VELOCITY_X,0) = 0.000000; -NODES[786](VELOCITY_Y,0) = 0.000000; -NODES[786](VELOCITY_Z,0) = 0.000000; -NODES[787](VELOCITY_X,0) = 0.000000; -NODES[787](VELOCITY_Y,0) = 0.000000; -NODES[787](VELOCITY_Z,0) = 0.000000; -NODES[788](VELOCITY_X,0) = 0.000000; -NODES[788](VELOCITY_Y,0) = 0.000000; -NODES[788](VELOCITY_Z,0) = 0.000000; -NODES[789](VELOCITY_X,0) = 0.000000; -NODES[789](VELOCITY_Y,0) = 0.000000; -NODES[789](VELOCITY_Z,0) = 0.000000; -NODES[790](VELOCITY_X,0) = 0.000000; -NODES[790](VELOCITY_Y,0) = 0.000000; -NODES[790](VELOCITY_Z,0) = 0.000000; -NODES[791](VELOCITY_X,0) = 0.000000; -NODES[791](VELOCITY_Y,0) = 0.000000; -NODES[791](VELOCITY_Z,0) = 0.000000; -NODES[792](VELOCITY_X,0) = 0.000000; -NODES[792](VELOCITY_Y,0) = 0.000000; -NODES[792](VELOCITY_Z,0) = 0.000000; -NODES[793](VELOCITY_X,0) = 0.000000; -NODES[793](VELOCITY_Y,0) = 0.000000; -NODES[793](VELOCITY_Z,0) = 0.000000; -NODES[794](VELOCITY_X,0) = 0.000000; -NODES[794](VELOCITY_Y,0) = 0.000000; -NODES[794](VELOCITY_Z,0) = 0.000000; -NODES[795](VELOCITY_X,0) = 0.000000; -NODES[795](VELOCITY_Y,0) = 0.000000; -NODES[795](VELOCITY_Z,0) = 0.000000; -NODES[796](VELOCITY_X,0) = 0.000000; -NODES[796](VELOCITY_Y,0) = 0.000000; -NODES[796](VELOCITY_Z,0) = 0.000000; -NODES[797](VELOCITY_X,0) = 0.000000; -NODES[797](VELOCITY_Y,0) = 0.000000; -NODES[797](VELOCITY_Z,0) = 0.000000; -NODES[798](VELOCITY_X,0) = 0.000000; -NODES[798](VELOCITY_Y,0) = 0.000000; -NODES[798](VELOCITY_Z,0) = 0.000000; -NODES[799](VELOCITY_X,0) = 0.000000; -NODES[799](VELOCITY_Y,0) = 0.000000; -NODES[799](VELOCITY_Z,0) = 0.000000; -NODES[800](VELOCITY_X,0) = 0.000000; -NODES[800](VELOCITY_Y,0) = 0.000000; -NODES[800](VELOCITY_Z,0) = 0.000000; -NODES[801](VELOCITY_X,0) = 0.000000; -NODES[801](VELOCITY_Y,0) = 0.000000; -NODES[801](VELOCITY_Z,0) = 0.000000; -NODES[802](VELOCITY_X,0) = 0.000000; -NODES[802](VELOCITY_Y,0) = 0.000000; -NODES[802](VELOCITY_Z,0) = 0.000000; -NODES[803](VELOCITY_X,0) = 0.000000; -NODES[803](VELOCITY_Y,0) = 0.000000; -NODES[803](VELOCITY_Z,0) = 0.000000; -NODES[804](VELOCITY_X,0) = 0.000000; -NODES[804](VELOCITY_Y,0) = 0.000000; -NODES[804](VELOCITY_Z,0) = 0.000000; -NODES[805](VELOCITY_X,0) = 0.000000; -NODES[805](VELOCITY_Y,0) = 0.000000; -NODES[805](VELOCITY_Z,0) = 0.000000; -NODES[806](VELOCITY_X,0) = 0.000000; -NODES[806](VELOCITY_Y,0) = 0.000000; -NODES[806](VELOCITY_Z,0) = 0.000000; -NODES[807](VELOCITY_X,0) = 0.000000; -NODES[807](VELOCITY_Y,0) = 0.000000; -NODES[807](VELOCITY_Z,0) = 0.000000; -NODES[808](VELOCITY_X,0) = 0.000000; -NODES[808](VELOCITY_Y,0) = 0.000000; -NODES[808](VELOCITY_Z,0) = 0.000000; -NODES[809](VELOCITY_X,0) = 0.000000; -NODES[809](VELOCITY_Y,0) = 0.000000; -NODES[809](VELOCITY_Z,0) = 0.000000; -NODES[810](VELOCITY_X,0) = 0.000000; -NODES[810](VELOCITY_Y,0) = 0.000000; -NODES[810](VELOCITY_Z,0) = 0.000000; -NODES[811](VELOCITY_X,0) = 0.000000; -NODES[811](VELOCITY_Y,0) = 0.000000; -NODES[811](VELOCITY_Z,0) = 0.000000; -NODES[812](VELOCITY_X,0) = 0.000000; -NODES[812](VELOCITY_Y,0) = 0.000000; -NODES[812](VELOCITY_Z,0) = 0.000000; -NODES[813](VELOCITY_X,0) = 0.000000; -NODES[813](VELOCITY_Y,0) = 0.000000; -NODES[813](VELOCITY_Z,0) = 0.000000; -NODES[814](VELOCITY_X,0) = 0.000000; -NODES[814](VELOCITY_Y,0) = 0.000000; -NODES[814](VELOCITY_Z,0) = 0.000000; -NODES[815](VELOCITY_X,0) = 0.000000; -NODES[815](VELOCITY_Y,0) = 0.000000; -NODES[815](VELOCITY_Z,0) = 0.000000; -NODES[816](VELOCITY_X,0) = 0.000000; -NODES[816](VELOCITY_Y,0) = 0.000000; -NODES[816](VELOCITY_Z,0) = 0.000000; -NODES[817](VELOCITY_X,0) = 0.000000; -NODES[817](VELOCITY_Y,0) = 0.000000; -NODES[817](VELOCITY_Z,0) = 0.000000; -NODES[818](VELOCITY_X,0) = 0.000000; -NODES[818](VELOCITY_Y,0) = 0.000000; -NODES[818](VELOCITY_Z,0) = 0.000000; -NODES[819](VELOCITY_X,0) = 0.000000; -NODES[819](VELOCITY_Y,0) = 0.000000; -NODES[819](VELOCITY_Z,0) = 0.000000; -NODES[820](VELOCITY_X,0) = 0.000000; -NODES[820](VELOCITY_Y,0) = 0.000000; -NODES[820](VELOCITY_Z,0) = 0.000000; -NODES[821](VELOCITY_X,0) = 0.000000; -NODES[821](VELOCITY_Y,0) = 0.000000; -NODES[821](VELOCITY_Z,0) = 0.000000; -NODES[822](VELOCITY_X,0) = 0.000000; -NODES[822](VELOCITY_Y,0) = 0.000000; -NODES[822](VELOCITY_Z,0) = 0.000000; -NODES[823](VELOCITY_X,0) = 0.000000; -NODES[823](VELOCITY_Y,0) = 0.000000; -NODES[823](VELOCITY_Z,0) = 0.000000; -NODES[824](VELOCITY_X,0) = 0.000000; -NODES[824](VELOCITY_Y,0) = 0.000000; -NODES[824](VELOCITY_Z,0) = 0.000000; -NODES[825](VELOCITY_X,0) = 0.000000; -NODES[825](VELOCITY_Y,0) = 0.000000; -NODES[825](VELOCITY_Z,0) = 0.000000; -NODES[826](VELOCITY_X,0) = 0.000000; -NODES[826](VELOCITY_Y,0) = 0.000000; -NODES[826](VELOCITY_Z,0) = 0.000000; -NODES[827](VELOCITY_X,0) = 0.000000; -NODES[827](VELOCITY_Y,0) = 0.000000; -NODES[827](VELOCITY_Z,0) = 0.000000; -NODES[828](VELOCITY_X,0) = 0.000000; -NODES[828](VELOCITY_Y,0) = 0.000000; -NODES[828](VELOCITY_Z,0) = 0.000000; -NODES[829](VELOCITY_X,0) = 0.000000; -NODES[829](VELOCITY_Y,0) = 0.000000; -NODES[829](VELOCITY_Z,0) = 0.000000; -NODES[830](VELOCITY_X,0) = 0.000000; -NODES[830](VELOCITY_Y,0) = 0.000000; -NODES[830](VELOCITY_Z,0) = 0.000000; -NODES[831](VELOCITY_X,0) = 0.000000; -NODES[831](VELOCITY_Y,0) = 0.000000; -NODES[831](VELOCITY_Z,0) = 0.000000; -NODES[832](VELOCITY_X,0) = 0.000000; -NODES[832](VELOCITY_Y,0) = 0.000000; -NODES[832](VELOCITY_Z,0) = 0.000000; -NODES[833](VELOCITY_X,0) = 0.000000; -NODES[833](VELOCITY_Y,0) = 0.000000; -NODES[833](VELOCITY_Z,0) = 0.000000; -NODES[834](VELOCITY_X,0) = 0.000000; -NODES[834](VELOCITY_Y,0) = 0.000000; -NODES[834](VELOCITY_Z,0) = 0.000000; -NODES[835](VELOCITY_X,0) = 0.000000; -NODES[835](VELOCITY_Y,0) = 0.000000; -NODES[835](VELOCITY_Z,0) = 0.000000; -NODES[836](VELOCITY_X,0) = 0.000000; -NODES[836](VELOCITY_Y,0) = 0.000000; -NODES[836](VELOCITY_Z,0) = 0.000000; -NODES[837](VELOCITY_X,0) = 0.000000; -NODES[837](VELOCITY_Y,0) = 0.000000; -NODES[837](VELOCITY_Z,0) = 0.000000; -NODES[838](VELOCITY_X,0) = 0.000000; -NODES[838](VELOCITY_Y,0) = 0.000000; -NODES[838](VELOCITY_Z,0) = 0.000000; -NODES[839](VELOCITY_X,0) = 0.000000; -NODES[839](VELOCITY_Y,0) = 0.000000; -NODES[839](VELOCITY_Z,0) = 0.000000; -NODES[840](VELOCITY_X,0) = 0.000000; -NODES[840](VELOCITY_Y,0) = 0.000000; -NODES[840](VELOCITY_Z,0) = 0.000000; -NODES[841](VELOCITY_X,0) = 0.000000; -NODES[841](VELOCITY_Y,0) = 0.000000; -NODES[841](VELOCITY_Z,0) = 0.000000; -NODES[842](VELOCITY_X,0) = 0.000000; -NODES[842](VELOCITY_Y,0) = 0.000000; -NODES[842](VELOCITY_Z,0) = 0.000000; -NODES[843](VELOCITY_X,0) = 0.000000; -NODES[843](VELOCITY_Y,0) = 0.000000; -NODES[843](VELOCITY_Z,0) = 0.000000; -NODES[844](VELOCITY_X,0) = 0.000000; -NODES[844](VELOCITY_Y,0) = 0.000000; -NODES[844](VELOCITY_Z,0) = 0.000000; -NODES[845](VELOCITY_X,0) = 0.000000; -NODES[845](VELOCITY_Y,0) = 0.000000; -NODES[845](VELOCITY_Z,0) = 0.000000; -NODES[846](VELOCITY_X,0) = 0.000000; -NODES[846](VELOCITY_Y,0) = 0.000000; -NODES[846](VELOCITY_Z,0) = 0.000000; -NODES[847](VELOCITY_X,0) = 0.000000; -NODES[847](VELOCITY_Y,0) = 0.000000; -NODES[847](VELOCITY_Z,0) = 0.000000; -NODES[848](VELOCITY_X,0) = 0.000000; -NODES[848](VELOCITY_Y,0) = 0.000000; -NODES[848](VELOCITY_Z,0) = 0.000000; -NODES[849](VELOCITY_X,0) = 0.000000; -NODES[849](VELOCITY_Y,0) = 0.000000; -NODES[849](VELOCITY_Z,0) = 0.000000; -NODES[850](VELOCITY_X,0) = 0.000000; -NODES[850](VELOCITY_Y,0) = 0.000000; -NODES[850](VELOCITY_Z,0) = 0.000000; -NODES[851](VELOCITY_X,0) = 0.000000; -NODES[851](VELOCITY_Y,0) = 0.000000; -NODES[851](VELOCITY_Z,0) = 0.000000; -NODES[852](VELOCITY_X,0) = 0.000000; -NODES[852](VELOCITY_Y,0) = 0.000000; -NODES[852](VELOCITY_Z,0) = 0.000000; -NODES[853](VELOCITY_X,0) = 0.000000; -NODES[853](VELOCITY_Y,0) = 0.000000; -NODES[853](VELOCITY_Z,0) = 0.000000; -NODES[854](VELOCITY_X,0) = 0.000000; -NODES[854](VELOCITY_Y,0) = 0.000000; -NODES[854](VELOCITY_Z,0) = 0.000000; -NODES[855](VELOCITY_X,0) = 0.000000; -NODES[855](VELOCITY_Y,0) = 0.000000; -NODES[855](VELOCITY_Z,0) = 0.000000; -NODES[856](VELOCITY_X,0) = 0.000000; -NODES[856](VELOCITY_Y,0) = 0.000000; -NODES[856](VELOCITY_Z,0) = 0.000000; -NODES[857](VELOCITY_X,0) = 0.000000; -NODES[857](VELOCITY_Y,0) = 0.000000; -NODES[857](VELOCITY_Z,0) = 0.000000; -NODES[858](VELOCITY_X,0) = 0.000000; -NODES[858](VELOCITY_Y,0) = 0.000000; -NODES[858](VELOCITY_Z,0) = 0.000000; -NODES[859](VELOCITY_X,0) = 0.000000; -NODES[859](VELOCITY_Y,0) = 0.000000; -NODES[859](VELOCITY_Z,0) = 0.000000; -NODES[860](VELOCITY_X,0) = 0.000000; -NODES[860](VELOCITY_Y,0) = 0.000000; -NODES[860](VELOCITY_Z,0) = 0.000000; -NODES[861](VELOCITY_X,0) = 0.000000; -NODES[861](VELOCITY_Y,0) = 0.000000; -NODES[861](VELOCITY_Z,0) = 0.000000; -NODES[862](VELOCITY_X,0) = 0.000000; -NODES[862](VELOCITY_Y,0) = 0.000000; -NODES[862](VELOCITY_Z,0) = 0.000000; -NODES[863](VELOCITY_X,0) = 0.000000; -NODES[863](VELOCITY_Y,0) = 0.000000; -NODES[863](VELOCITY_Z,0) = 0.000000; -NODES[864](VELOCITY_X,0) = 0.000000; -NODES[864](VELOCITY_Y,0) = 0.000000; -NODES[864](VELOCITY_Z,0) = 0.000000; -NODES[865](VELOCITY_X,0) = 0.000000; -NODES[865](VELOCITY_Y,0) = 0.000000; -NODES[865](VELOCITY_Z,0) = 0.000000; -NODES[866](VELOCITY_X,0) = 0.000000; -NODES[866](VELOCITY_Y,0) = 0.000000; -NODES[866](VELOCITY_Z,0) = 0.000000; -NODES[867](VELOCITY_X,0) = 0.000000; -NODES[867](VELOCITY_Y,0) = 0.000000; -NODES[867](VELOCITY_Z,0) = 0.000000; -NODES[868](VELOCITY_X,0) = 0.000000; -NODES[868](VELOCITY_Y,0) = 0.000000; -NODES[868](VELOCITY_Z,0) = 0.000000; -NODES[869](VELOCITY_X,0) = 0.000000; -NODES[869](VELOCITY_Y,0) = 0.000000; -NODES[869](VELOCITY_Z,0) = 0.000000; -NODES[870](VELOCITY_X,0) = 0.000000; -NODES[870](VELOCITY_Y,0) = 0.000000; -NODES[870](VELOCITY_Z,0) = 0.000000; -NODES[871](VELOCITY_X,0) = 0.000000; -NODES[871](VELOCITY_Y,0) = 0.000000; -NODES[871](VELOCITY_Z,0) = 0.000000; -NODES[872](VELOCITY_X,0) = 0.000000; -NODES[872](VELOCITY_Y,0) = 0.000000; -NODES[872](VELOCITY_Z,0) = 0.000000; -NODES[873](VELOCITY_X,0) = 0.000000; -NODES[873](VELOCITY_Y,0) = 0.000000; -NODES[873](VELOCITY_Z,0) = 0.000000; -NODES[874](VELOCITY_X,0) = 0.000000; -NODES[874](VELOCITY_Y,0) = 0.000000; -NODES[874](VELOCITY_Z,0) = 0.000000; -NODES[875](VELOCITY_X,0) = 0.000000; -NODES[875](VELOCITY_Y,0) = 0.000000; -NODES[875](VELOCITY_Z,0) = 0.000000; -NODES[876](VELOCITY_X,0) = 0.000000; -NODES[876](VELOCITY_Y,0) = 0.000000; -NODES[876](VELOCITY_Z,0) = 0.000000; -NODES[877](VELOCITY_X,0) = 0.000000; -NODES[877](VELOCITY_Y,0) = 0.000000; -NODES[877](VELOCITY_Z,0) = 0.000000; -NODES[878](VELOCITY_X,0) = 0.000000; -NODES[878](VELOCITY_Y,0) = 0.000000; -NODES[878](VELOCITY_Z,0) = 0.000000; -NODES[879](VELOCITY_X,0) = 0.000000; -NODES[879](VELOCITY_Y,0) = 0.000000; -NODES[879](VELOCITY_Z,0) = 0.000000; -NODES[880](VELOCITY_X,0) = 0.000000; -NODES[880](VELOCITY_Y,0) = 0.000000; -NODES[880](VELOCITY_Z,0) = 0.000000; -NODES[881](VELOCITY_X,0) = 0.000000; -NODES[881](VELOCITY_Y,0) = 0.000000; -NODES[881](VELOCITY_Z,0) = 0.000000; -NODES[882](VELOCITY_X,0) = 0.000000; -NODES[882](VELOCITY_Y,0) = 0.000000; -NODES[882](VELOCITY_Z,0) = 0.000000; -NODES[883](VELOCITY_X,0) = 0.000000; -NODES[883](VELOCITY_Y,0) = 0.000000; -NODES[883](VELOCITY_Z,0) = 0.000000; -NODES[884](VELOCITY_X,0) = 0.000000; -NODES[884](VELOCITY_Y,0) = 0.000000; -NODES[884](VELOCITY_Z,0) = 0.000000; -NODES[885](VELOCITY_X,0) = 0.000000; -NODES[885](VELOCITY_Y,0) = 0.000000; -NODES[885](VELOCITY_Z,0) = 0.000000; -NODES[886](VELOCITY_X,0) = 0.000000; -NODES[886](VELOCITY_Y,0) = 0.000000; -NODES[886](VELOCITY_Z,0) = 0.000000; -NODES[887](VELOCITY_X,0) = 0.000000; -NODES[887](VELOCITY_Y,0) = 0.000000; -NODES[887](VELOCITY_Z,0) = 0.000000; -NODES[888](VELOCITY_X,0) = 0.000000; -NODES[888](VELOCITY_Y,0) = 0.000000; -NODES[888](VELOCITY_Z,0) = 0.000000; -NODES[889](VELOCITY_X,0) = 0.000000; -NODES[889](VELOCITY_Y,0) = 0.000000; -NODES[889](VELOCITY_Z,0) = 0.000000; -NODES[890](VELOCITY_X,0) = 0.000000; -NODES[890](VELOCITY_Y,0) = 0.000000; -NODES[890](VELOCITY_Z,0) = 0.000000; -NODES[891](VELOCITY_X,0) = 0.000000; -NODES[891](VELOCITY_Y,0) = 0.000000; -NODES[891](VELOCITY_Z,0) = 0.000000; -NODES[892](VELOCITY_X,0) = 0.000000; -NODES[892](VELOCITY_Y,0) = 0.000000; -NODES[892](VELOCITY_Z,0) = 0.000000; -NODES[893](VELOCITY_X,0) = 0.000000; -NODES[893](VELOCITY_Y,0) = 0.000000; -NODES[893](VELOCITY_Z,0) = 0.000000; -NODES[894](VELOCITY_X,0) = 0.000000; -NODES[894](VELOCITY_Y,0) = 0.000000; -NODES[894](VELOCITY_Z,0) = 0.000000; -NODES[895](VELOCITY_X,0) = 0.000000; -NODES[895](VELOCITY_Y,0) = 0.000000; -NODES[895](VELOCITY_Z,0) = 0.000000; -NODES[896](VELOCITY_X,0) = 0.000000; -NODES[896](VELOCITY_Y,0) = 0.000000; -NODES[896](VELOCITY_Z,0) = 0.000000; -NODES[897](VELOCITY_X,0) = 0.000000; -NODES[897](VELOCITY_Y,0) = 0.000000; -NODES[897](VELOCITY_Z,0) = 0.000000; -NODES[898](VELOCITY_X,0) = 0.000000; -NODES[898](VELOCITY_Y,0) = 0.000000; -NODES[898](VELOCITY_Z,0) = 0.000000; -NODES[899](VELOCITY_X,0) = 0.000000; -NODES[899](VELOCITY_Y,0) = 0.000000; -NODES[899](VELOCITY_Z,0) = 0.000000; -NODES[900](VELOCITY_X,0) = 0.000000; -NODES[900](VELOCITY_Y,0) = 0.000000; -NODES[900](VELOCITY_Z,0) = 0.000000; -NODES[901](VELOCITY_X,0) = 0.000000; -NODES[901](VELOCITY_Y,0) = 0.000000; -NODES[901](VELOCITY_Z,0) = 0.000000; -NODES[902](VELOCITY_X,0) = 0.000000; -NODES[902](VELOCITY_Y,0) = 0.000000; -NODES[902](VELOCITY_Z,0) = 0.000000; -NODES[903](VELOCITY_X,0) = 0.000000; -NODES[903](VELOCITY_Y,0) = 0.000000; -NODES[903](VELOCITY_Z,0) = 0.000000; -NODES[904](VELOCITY_X,0) = 0.000000; -NODES[904](VELOCITY_Y,0) = 0.000000; -NODES[904](VELOCITY_Z,0) = 0.000000; -NODES[905](VELOCITY_X,0) = 0.000000; -NODES[905](VELOCITY_Y,0) = 0.000000; -NODES[905](VELOCITY_Z,0) = 0.000000; -NODES[906](VELOCITY_X,0) = 0.000000; -NODES[906](VELOCITY_Y,0) = 0.000000; -NODES[906](VELOCITY_Z,0) = 0.000000; -NODES[907](VELOCITY_X,0) = 0.000000; -NODES[907](VELOCITY_Y,0) = 0.000000; -NODES[907](VELOCITY_Z,0) = 0.000000; -NODES[908](VELOCITY_X,0) = 0.000000; -NODES[908](VELOCITY_Y,0) = 0.000000; -NODES[908](VELOCITY_Z,0) = 0.000000; -NODES[909](VELOCITY_X,0) = 0.000000; -NODES[909](VELOCITY_Y,0) = 0.000000; -NODES[909](VELOCITY_Z,0) = 0.000000; -NODES[910](VELOCITY_X,0) = 0.000000; -NODES[910](VELOCITY_Y,0) = 0.000000; -NODES[910](VELOCITY_Z,0) = 0.000000; -NODES[911](VELOCITY_X,0) = 0.000000; -NODES[911](VELOCITY_Y,0) = 0.000000; -NODES[911](VELOCITY_Z,0) = 0.000000; -NODES[912](VELOCITY_X,0) = 0.000000; -NODES[912](VELOCITY_Y,0) = 0.000000; -NODES[912](VELOCITY_Z,0) = 0.000000; -NODES[913](VELOCITY_X,0) = 0.000000; -NODES[913](VELOCITY_Y,0) = 0.000000; -NODES[913](VELOCITY_Z,0) = 0.000000; -NODES[914](VELOCITY_X,0) = 0.000000; -NODES[914](VELOCITY_Y,0) = 0.000000; -NODES[914](VELOCITY_Z,0) = 0.000000; -NODES[915](VELOCITY_X,0) = 0.000000; -NODES[915](VELOCITY_Y,0) = 0.000000; -NODES[915](VELOCITY_Z,0) = 0.000000; -NODES[916](VELOCITY_X,0) = 0.000000; -NODES[916](VELOCITY_Y,0) = 0.000000; -NODES[916](VELOCITY_Z,0) = 0.000000; -NODES[917](VELOCITY_X,0) = 0.000000; -NODES[917](VELOCITY_Y,0) = 0.000000; -NODES[917](VELOCITY_Z,0) = 0.000000; -NODES[918](VELOCITY_X,0) = 0.000000; -NODES[918](VELOCITY_Y,0) = 0.000000; -NODES[918](VELOCITY_Z,0) = 0.000000; -NODES[919](VELOCITY_X,0) = 0.000000; -NODES[919](VELOCITY_Y,0) = 0.000000; -NODES[919](VELOCITY_Z,0) = 0.000000; -NODES[920](VELOCITY_X,0) = 0.000000; -NODES[920](VELOCITY_Y,0) = 0.000000; -NODES[920](VELOCITY_Z,0) = 0.000000; -NODES[921](VELOCITY_X,0) = 0.000000; -NODES[921](VELOCITY_Y,0) = 0.000000; -NODES[921](VELOCITY_Z,0) = 0.000000; -NODES[922](VELOCITY_X,0) = 0.000000; -NODES[922](VELOCITY_Y,0) = 0.000000; -NODES[922](VELOCITY_Z,0) = 0.000000; -NODES[923](VELOCITY_X,0) = 0.000000; -NODES[923](VELOCITY_Y,0) = 0.000000; -NODES[923](VELOCITY_Z,0) = 0.000000; -NODES[924](VELOCITY_X,0) = 0.000000; -NODES[924](VELOCITY_Y,0) = 0.000000; -NODES[924](VELOCITY_Z,0) = 0.000000; -NODES[925](VELOCITY_X,0) = 0.000000; -NODES[925](VELOCITY_Y,0) = 0.000000; -NODES[925](VELOCITY_Z,0) = 0.000000; -NODES[926](VELOCITY_X,0) = 0.000000; -NODES[926](VELOCITY_Y,0) = 0.000000; -NODES[926](VELOCITY_Z,0) = 0.000000; -NODES[927](VELOCITY_X,0) = 0.000000; -NODES[927](VELOCITY_Y,0) = 0.000000; -NODES[927](VELOCITY_Z,0) = 0.000000; -NODES[928](VELOCITY_X,0) = 0.000000; -NODES[928](VELOCITY_Y,0) = 0.000000; -NODES[928](VELOCITY_Z,0) = 0.000000; -NODES[929](VELOCITY_X,0) = 0.000000; -NODES[929](VELOCITY_Y,0) = 0.000000; -NODES[929](VELOCITY_Z,0) = 0.000000; -NODES[930](VELOCITY_X,0) = 0.000000; -NODES[930](VELOCITY_Y,0) = 0.000000; -NODES[930](VELOCITY_Z,0) = 0.000000; -NODES[931](VELOCITY_X,0) = 0.000000; -NODES[931](VELOCITY_Y,0) = 0.000000; -NODES[931](VELOCITY_Z,0) = 0.000000; -NODES[932](VELOCITY_X,0) = 0.000000; -NODES[932](VELOCITY_Y,0) = 0.000000; -NODES[932](VELOCITY_Z,0) = 0.000000; -NODES[933](VELOCITY_X,0) = 0.000000; -NODES[933](VELOCITY_Y,0) = 0.000000; -NODES[933](VELOCITY_Z,0) = 0.000000; -NODES[934](VELOCITY_X,0) = 0.000000; -NODES[934](VELOCITY_Y,0) = 0.000000; -NODES[934](VELOCITY_Z,0) = 0.000000; -NODES[935](VELOCITY_X,0) = 0.000000; -NODES[935](VELOCITY_Y,0) = 0.000000; -NODES[935](VELOCITY_Z,0) = 0.000000; -NODES[936](VELOCITY_X,0) = 0.000000; -NODES[936](VELOCITY_Y,0) = 0.000000; -NODES[936](VELOCITY_Z,0) = 0.000000; -NODES[937](VELOCITY_X,0) = 0.000000; -NODES[937](VELOCITY_Y,0) = 0.000000; -NODES[937](VELOCITY_Z,0) = 0.000000; -NODES[938](VELOCITY_X,0) = 0.000000; -NODES[938](VELOCITY_Y,0) = 0.000000; -NODES[938](VELOCITY_Z,0) = 0.000000; -NODES[939](VELOCITY_X,0) = 0.000000; -NODES[939](VELOCITY_Y,0) = 0.000000; -NODES[939](VELOCITY_Z,0) = 0.000000; -NODES[940](VELOCITY_X,0) = 0.000000; -NODES[940](VELOCITY_Y,0) = 0.000000; -NODES[940](VELOCITY_Z,0) = 0.000000; -NODES[941](VELOCITY_X,0) = 0.000000; -NODES[941](VELOCITY_Y,0) = 0.000000; -NODES[941](VELOCITY_Z,0) = 0.000000; -NODES[942](VELOCITY_X,0) = 0.000000; -NODES[942](VELOCITY_Y,0) = 0.000000; -NODES[942](VELOCITY_Z,0) = 0.000000; -NODES[943](VELOCITY_X,0) = 0.000000; -NODES[943](VELOCITY_Y,0) = 0.000000; -NODES[943](VELOCITY_Z,0) = 0.000000; -NODES[944](VELOCITY_X,0) = 0.000000; -NODES[944](VELOCITY_Y,0) = 0.000000; -NODES[944](VELOCITY_Z,0) = 0.000000; -NODES[945](VELOCITY_X,0) = 0.000000; -NODES[945](VELOCITY_Y,0) = 0.000000; -NODES[945](VELOCITY_Z,0) = 0.000000; -NODES[946](VELOCITY_X,0) = 0.000000; -NODES[946](VELOCITY_Y,0) = 0.000000; -NODES[946](VELOCITY_Z,0) = 0.000000; -NODES[947](VELOCITY_X,0) = 0.000000; -NODES[947](VELOCITY_Y,0) = 0.000000; -NODES[947](VELOCITY_Z,0) = 0.000000; -NODES[948](VELOCITY_X,0) = 0.000000; -NODES[948](VELOCITY_Y,0) = 0.000000; -NODES[948](VELOCITY_Z,0) = 0.000000; -NODES[949](VELOCITY_X,0) = 0.000000; -NODES[949](VELOCITY_Y,0) = 0.000000; -NODES[949](VELOCITY_Z,0) = 0.000000; -NODES[950](VELOCITY_X,0) = 0.000000; -NODES[950](VELOCITY_Y,0) = 0.000000; -NODES[950](VELOCITY_Z,0) = 0.000000; -NODES[951](VELOCITY_X,0) = 0.000000; -NODES[951](VELOCITY_Y,0) = 0.000000; -NODES[951](VELOCITY_Z,0) = 0.000000; -NODES[952](VELOCITY_X,0) = 0.000000; -NODES[952](VELOCITY_Y,0) = 0.000000; -NODES[952](VELOCITY_Z,0) = 0.000000; -NODES[953](VELOCITY_X,0) = 0.000000; -NODES[953](VELOCITY_Y,0) = 0.000000; -NODES[953](VELOCITY_Z,0) = 0.000000; -NODES[954](VELOCITY_X,0) = 0.000000; -NODES[954](VELOCITY_Y,0) = 0.000000; -NODES[954](VELOCITY_Z,0) = 0.000000; -NODES[955](VELOCITY_X,0) = 0.000000; -NODES[955](VELOCITY_Y,0) = 0.000000; -NODES[955](VELOCITY_Z,0) = 0.000000; -NODES[956](VELOCITY_X,0) = 0.000000; -NODES[956](VELOCITY_Y,0) = 0.000000; -NODES[956](VELOCITY_Z,0) = 0.000000; -NODES[957](VELOCITY_X,0) = 0.000000; -NODES[957](VELOCITY_Y,0) = 0.000000; -NODES[957](VELOCITY_Z,0) = 0.000000; -NODES[958](VELOCITY_X,0) = 0.000000; -NODES[958](VELOCITY_Y,0) = 0.000000; -NODES[958](VELOCITY_Z,0) = 0.000000; -NODES[959](VELOCITY_X,0) = 0.000000; -NODES[959](VELOCITY_Y,0) = 0.000000; -NODES[959](VELOCITY_Z,0) = 0.000000; -NODES[960](VELOCITY_X,0) = 0.000000; -NODES[960](VELOCITY_Y,0) = 0.000000; -NODES[960](VELOCITY_Z,0) = 0.000000; -NODES[961](VELOCITY_X,0) = 0.000000; -NODES[961](VELOCITY_Y,0) = 0.000000; -NODES[961](VELOCITY_Z,0) = 0.000000; -NODES[962](VELOCITY_X,0) = 0.000000; -NODES[962](VELOCITY_Y,0) = 0.000000; -NODES[962](VELOCITY_Z,0) = 0.000000; -NODES[963](VELOCITY_X,0) = 0.000000; -NODES[963](VELOCITY_Y,0) = 0.000000; -NODES[963](VELOCITY_Z,0) = 0.000000; -NODES[964](VELOCITY_X,0) = 0.000000; -NODES[964](VELOCITY_Y,0) = 0.000000; -NODES[964](VELOCITY_Z,0) = 0.000000; -NODES[965](VELOCITY_X,0) = 0.000000; -NODES[965](VELOCITY_Y,0) = 0.000000; -NODES[965](VELOCITY_Z,0) = 0.000000; -NODES[966](VELOCITY_X,0) = 0.000000; -NODES[966](VELOCITY_Y,0) = 0.000000; -NODES[966](VELOCITY_Z,0) = 0.000000; -NODES[967](VELOCITY_X,0) = 0.000000; -NODES[967](VELOCITY_Y,0) = 0.000000; -NODES[967](VELOCITY_Z,0) = 0.000000; -NODES[968](VELOCITY_X,0) = 0.000000; -NODES[968](VELOCITY_Y,0) = 0.000000; -NODES[968](VELOCITY_Z,0) = 0.000000; -NODES[969](VELOCITY_X,0) = 0.000000; -NODES[969](VELOCITY_Y,0) = 0.000000; -NODES[969](VELOCITY_Z,0) = 0.000000; -NODES[970](VELOCITY_X,0) = 0.000000; -NODES[970](VELOCITY_Y,0) = 0.000000; -NODES[970](VELOCITY_Z,0) = 0.000000; -NODES[971](VELOCITY_X,0) = 0.000000; -NODES[971](VELOCITY_Y,0) = 0.000000; -NODES[971](VELOCITY_Z,0) = 0.000000; -NODES[972](VELOCITY_X,0) = 0.000000; -NODES[972](VELOCITY_Y,0) = 0.000000; -NODES[972](VELOCITY_Z,0) = 0.000000; -NODES[973](VELOCITY_X,0) = 0.000000; -NODES[973](VELOCITY_Y,0) = 0.000000; -NODES[973](VELOCITY_Z,0) = 0.000000; -NODES[974](VELOCITY_X,0) = 0.000000; -NODES[974](VELOCITY_Y,0) = 0.000000; -NODES[974](VELOCITY_Z,0) = 0.000000; -NODES[975](VELOCITY_X,0) = 0.000000; -NODES[975](VELOCITY_Y,0) = 0.000000; -NODES[975](VELOCITY_Z,0) = 0.000000; -NODES[976](VELOCITY_X,0) = 0.000000; -NODES[976](VELOCITY_Y,0) = 0.000000; -NODES[976](VELOCITY_Z,0) = 0.000000; -NODES[977](VELOCITY_X,0) = 0.000000; -NODES[977](VELOCITY_Y,0) = 0.000000; -NODES[977](VELOCITY_Z,0) = 0.000000; -NODES[978](VELOCITY_X,0) = 0.000000; -NODES[978](VELOCITY_Y,0) = 0.000000; -NODES[978](VELOCITY_Z,0) = 0.000000; -NODES[979](VELOCITY_X,0) = 0.000000; -NODES[979](VELOCITY_Y,0) = 0.000000; -NODES[979](VELOCITY_Z,0) = 0.000000; -NODES[980](VELOCITY_X,0) = 0.000000; -NODES[980](VELOCITY_Y,0) = 0.000000; -NODES[980](VELOCITY_Z,0) = 0.000000; -NODES[981](VELOCITY_X,0) = 0.000000; -NODES[981](VELOCITY_Y,0) = 0.000000; -NODES[981](VELOCITY_Z,0) = 0.000000; -NODES[982](VELOCITY_X,0) = 0.000000; -NODES[982](VELOCITY_Y,0) = 0.000000; -NODES[982](VELOCITY_Z,0) = 0.000000; -NODES[983](VELOCITY_X,0) = 0.000000; -NODES[983](VELOCITY_Y,0) = 0.000000; -NODES[983](VELOCITY_Z,0) = 0.000000; -NODES[984](VELOCITY_X,0) = 0.000000; -NODES[984](VELOCITY_Y,0) = 0.000000; -NODES[984](VELOCITY_Z,0) = 0.000000; -NODES[985](VELOCITY_X,0) = 0.000000; -NODES[985](VELOCITY_Y,0) = 0.000000; -NODES[985](VELOCITY_Z,0) = 0.000000; -NODES[986](VELOCITY_X,0) = 0.000000; -NODES[986](VELOCITY_Y,0) = 0.000000; -NODES[986](VELOCITY_Z,0) = 0.000000; -NODES[987](VELOCITY_X,0) = 0.000000; -NODES[987](VELOCITY_Y,0) = 0.000000; -NODES[987](VELOCITY_Z,0) = 0.000000; -NODES[988](VELOCITY_X,0) = 0.000000; -NODES[988](VELOCITY_Y,0) = 0.000000; -NODES[988](VELOCITY_Z,0) = 0.000000; -NODES[989](VELOCITY_X,0) = 0.000000; -NODES[989](VELOCITY_Y,0) = 0.000000; -NODES[989](VELOCITY_Z,0) = 0.000000; -NODES[990](VELOCITY_X,0) = 0.000000; -NODES[990](VELOCITY_Y,0) = 0.000000; -NODES[990](VELOCITY_Z,0) = 0.000000; -NODES[991](VELOCITY_X,0) = 0.000000; -NODES[991](VELOCITY_Y,0) = 0.000000; -NODES[991](VELOCITY_Z,0) = 0.000000; -NODES[992](VELOCITY_X,0) = 0.000000; -NODES[992](VELOCITY_Y,0) = 0.000000; -NODES[992](VELOCITY_Z,0) = 0.000000; -NODES[993](VELOCITY_X,0) = 0.000000; -NODES[993](VELOCITY_Y,0) = 0.000000; -NODES[993](VELOCITY_Z,0) = 0.000000; -NODES[994](VELOCITY_X,0) = 0.000000; -NODES[994](VELOCITY_Y,0) = 0.000000; -NODES[994](VELOCITY_Z,0) = 0.000000; -NODES[995](VELOCITY_X,0) = 0.000000; -NODES[995](VELOCITY_Y,0) = 0.000000; -NODES[995](VELOCITY_Z,0) = 0.000000; -NODES[996](VELOCITY_X,0) = 0.000000; -NODES[996](VELOCITY_Y,0) = 0.000000; -NODES[996](VELOCITY_Z,0) = 0.000000; -NODES[997](VELOCITY_X,0) = 0.000000; -NODES[997](VELOCITY_Y,0) = 0.000000; -NODES[997](VELOCITY_Z,0) = 0.000000; -NODES[998](VELOCITY_X,0) = 0.000000; -NODES[998](VELOCITY_Y,0) = 0.000000; -NODES[998](VELOCITY_Z,0) = 0.000000; -NODES[999](VELOCITY_X,0) = 0.000000; -NODES[999](VELOCITY_Y,0) = 0.000000; -NODES[999](VELOCITY_Z,0) = 0.000000; -NODES[1000](VELOCITY_X,0) = 0.000000; -NODES[1000](VELOCITY_Y,0) = 0.000000; -NODES[1000](VELOCITY_Z,0) = 0.000000; -NODES[1001](VELOCITY_X,0) = 0.000000; -NODES[1001](VELOCITY_Y,0) = 0.000000; -NODES[1001](VELOCITY_Z,0) = 0.000000; -NODES[1002](VELOCITY_X,0) = 0.000000; -NODES[1002](VELOCITY_Y,0) = 0.000000; -NODES[1002](VELOCITY_Z,0) = 0.000000; -NODES[1003](VELOCITY_X,0) = 0.000000; -NODES[1003](VELOCITY_Y,0) = 0.000000; -NODES[1003](VELOCITY_Z,0) = 0.000000; -NODES[1004](VELOCITY_X,0) = 0.000000; -NODES[1004](VELOCITY_Y,0) = 0.000000; -NODES[1004](VELOCITY_Z,0) = 0.000000; -NODES[1005](VELOCITY_X,0) = 0.000000; -NODES[1005](VELOCITY_Y,0) = 0.000000; -NODES[1005](VELOCITY_Z,0) = 0.000000; -NODES[1006](VELOCITY_X,0) = 0.000000; -NODES[1006](VELOCITY_Y,0) = 0.000000; -NODES[1006](VELOCITY_Z,0) = 0.000000; -NODES[1007](VELOCITY_X,0) = 0.000000; -NODES[1007](VELOCITY_Y,0) = 0.000000; -NODES[1007](VELOCITY_Z,0) = 0.000000; -NODES[1008](VELOCITY_X,0) = 0.000000; -NODES[1008](VELOCITY_Y,0) = 0.000000; -NODES[1008](VELOCITY_Z,0) = 0.000000; -NODES[1009](VELOCITY_X,0) = 0.000000; -NODES[1009](VELOCITY_Y,0) = 0.000000; -NODES[1009](VELOCITY_Z,0) = 0.000000; -NODES[1010](VELOCITY_X,0) = 0.000000; -NODES[1010](VELOCITY_Y,0) = 0.000000; -NODES[1010](VELOCITY_Z,0) = 0.000000; -NODES[1011](VELOCITY_X,0) = 0.000000; -NODES[1011](VELOCITY_Y,0) = 0.000000; -NODES[1011](VELOCITY_Z,0) = 0.000000; -NODES[1012](VELOCITY_X,0) = 0.000000; -NODES[1012](VELOCITY_Y,0) = 0.000000; -NODES[1012](VELOCITY_Z,0) = 0.000000; -NODES[1013](VELOCITY_X,0) = 0.000000; -NODES[1013](VELOCITY_Y,0) = 0.000000; -NODES[1013](VELOCITY_Z,0) = 0.000000; -NODES[1014](VELOCITY_X,0) = 0.000000; -NODES[1014](VELOCITY_Y,0) = 0.000000; -NODES[1014](VELOCITY_Z,0) = 0.000000; -NODES[1015](VELOCITY_X,0) = 0.000000; -NODES[1015](VELOCITY_Y,0) = 0.000000; -NODES[1015](VELOCITY_Z,0) = 0.000000; -NODES[1016](VELOCITY_X,0) = 0.000000; -NODES[1016](VELOCITY_Y,0) = 0.000000; -NODES[1016](VELOCITY_Z,0) = 0.000000; -NODES[1017](VELOCITY_X,0) = 0.000000; -NODES[1017](VELOCITY_Y,0) = 0.000000; -NODES[1017](VELOCITY_Z,0) = 0.000000; -NODES[1018](VELOCITY_X,0) = 0.000000; -NODES[1018](VELOCITY_Y,0) = 0.000000; -NODES[1018](VELOCITY_Z,0) = 0.000000; -NODES[1019](VELOCITY_X,0) = 0.000000; -NODES[1019](VELOCITY_Y,0) = 0.000000; -NODES[1019](VELOCITY_Z,0) = 0.000000; -NODES[1020](VELOCITY_X,0) = 0.000000; -NODES[1020](VELOCITY_Y,0) = 0.000000; -NODES[1020](VELOCITY_Z,0) = 0.000000; -NODES[1021](VELOCITY_X,0) = 0.000000; -NODES[1021](VELOCITY_Y,0) = 0.000000; -NODES[1021](VELOCITY_Z,0) = 0.000000; -NODES[1022](VELOCITY_X,0) = 0.000000; -NODES[1022](VELOCITY_Y,0) = 0.000000; -NODES[1022](VELOCITY_Z,0) = 0.000000; -NODES[1023](VELOCITY_X,0) = 0.000000; -NODES[1023](VELOCITY_Y,0) = 0.000000; -NODES[1023](VELOCITY_Z,0) = 0.000000; -NODES[1024](VELOCITY_X,0) = 0.000000; -NODES[1024](VELOCITY_Y,0) = 0.000000; -NODES[1024](VELOCITY_Z,0) = 0.000000; -NODES[1025](VELOCITY_X,0) = 0.000000; -NODES[1025](VELOCITY_Y,0) = 0.000000; -NODES[1025](VELOCITY_Z,0) = 0.000000; -NODES[1026](VELOCITY_X,0) = 0.000000; -NODES[1026](VELOCITY_Y,0) = 0.000000; -NODES[1026](VELOCITY_Z,0) = 0.000000; -NODES[1027](VELOCITY_X,0) = 0.000000; -NODES[1027](VELOCITY_Y,0) = 0.000000; -NODES[1027](VELOCITY_Z,0) = 0.000000; -NODES[1028](VELOCITY_X,0) = 0.000000; -NODES[1028](VELOCITY_Y,0) = 0.000000; -NODES[1028](VELOCITY_Z,0) = 0.000000; -NODES[1029](VELOCITY_X,0) = 0.000000; -NODES[1029](VELOCITY_Y,0) = 0.000000; -NODES[1029](VELOCITY_Z,0) = 0.000000; -NODES[1030](VELOCITY_X,0) = 0.000000; -NODES[1030](VELOCITY_Y,0) = 0.000000; -NODES[1030](VELOCITY_Z,0) = 0.000000; -NODES[1031](VELOCITY_X,0) = 0.000000; -NODES[1031](VELOCITY_Y,0) = 0.000000; -NODES[1031](VELOCITY_Z,0) = 0.000000; -NODES[1032](VELOCITY_X,0) = 0.000000; -NODES[1032](VELOCITY_Y,0) = 0.000000; -NODES[1032](VELOCITY_Z,0) = 0.000000; -NODES[1033](VELOCITY_X,0) = 0.000000; -NODES[1033](VELOCITY_Y,0) = 0.000000; -NODES[1033](VELOCITY_Z,0) = 0.000000; -NODES[1034](VELOCITY_X,0) = 0.000000; -NODES[1034](VELOCITY_Y,0) = 0.000000; -NODES[1034](VELOCITY_Z,0) = 0.000000; -NODES[1035](VELOCITY_X,0) = 0.000000; -NODES[1035](VELOCITY_Y,0) = 0.000000; -NODES[1035](VELOCITY_Z,0) = 0.000000; -NODES[1036](VELOCITY_X,0) = 0.000000; -NODES[1036](VELOCITY_Y,0) = 0.000000; -NODES[1036](VELOCITY_Z,0) = 0.000000; -NODES[1037](VELOCITY_X,0) = 0.000000; -NODES[1037](VELOCITY_Y,0) = 0.000000; -NODES[1037](VELOCITY_Z,0) = 0.000000; -NODES[1038](VELOCITY_X,0) = 0.000000; -NODES[1038](VELOCITY_Y,0) = 0.000000; -NODES[1038](VELOCITY_Z,0) = 0.000000; -NODES[1039](VELOCITY_X,0) = 0.000000; -NODES[1039](VELOCITY_Y,0) = 0.000000; -NODES[1039](VELOCITY_Z,0) = 0.000000; -NODES[1040](VELOCITY_X,0) = 0.000000; -NODES[1040](VELOCITY_Y,0) = 0.000000; -NODES[1040](VELOCITY_Z,0) = 0.000000; -NODES[1041](VELOCITY_X,0) = 0.000000; -NODES[1041](VELOCITY_Y,0) = 0.000000; -NODES[1041](VELOCITY_Z,0) = 0.000000; -NODES[1042](VELOCITY_X,0) = 0.000000; -NODES[1042](VELOCITY_Y,0) = 0.000000; -NODES[1042](VELOCITY_Z,0) = 0.000000; -NODES[1043](VELOCITY_X,0) = 0.000000; -NODES[1043](VELOCITY_Y,0) = 0.000000; -NODES[1043](VELOCITY_Z,0) = 0.000000; -NODES[1044](VELOCITY_X,0) = 0.000000; -NODES[1044](VELOCITY_Y,0) = 0.000000; -NODES[1044](VELOCITY_Z,0) = 0.000000; -NODES[1045](VELOCITY_X,0) = 0.000000; -NODES[1045](VELOCITY_Y,0) = 0.000000; -NODES[1045](VELOCITY_Z,0) = 0.000000; -NODES[1046](VELOCITY_X,0) = 0.000000; -NODES[1046](VELOCITY_Y,0) = 0.000000; -NODES[1046](VELOCITY_Z,0) = 0.000000; -NODES[1047](VELOCITY_X,0) = 0.000000; -NODES[1047](VELOCITY_Y,0) = 0.000000; -NODES[1047](VELOCITY_Z,0) = 0.000000; -NODES[1048](VELOCITY_X,0) = 0.000000; -NODES[1048](VELOCITY_Y,0) = 0.000000; -NODES[1048](VELOCITY_Z,0) = 0.000000; -NODES[1049](VELOCITY_X,0) = 0.000000; -NODES[1049](VELOCITY_Y,0) = 0.000000; -NODES[1049](VELOCITY_Z,0) = 0.000000; -NODES[1050](VELOCITY_X,0) = 0.000000; -NODES[1050](VELOCITY_Y,0) = 0.000000; -NODES[1050](VELOCITY_Z,0) = 0.000000; -NODES[1051](VELOCITY_X,0) = 0.000000; -NODES[1051](VELOCITY_Y,0) = 0.000000; -NODES[1051](VELOCITY_Z,0) = 0.000000; -NODES[1052](VELOCITY_X,0) = 0.000000; -NODES[1052](VELOCITY_Y,0) = 0.000000; -NODES[1052](VELOCITY_Z,0) = 0.000000; -NODES[1053](VELOCITY_X,0) = 0.000000; -NODES[1053](VELOCITY_Y,0) = 0.000000; -NODES[1053](VELOCITY_Z,0) = 0.000000; -NODES[1054](VELOCITY_X,0) = 0.000000; -NODES[1054](VELOCITY_Y,0) = 0.000000; -NODES[1054](VELOCITY_Z,0) = 0.000000; -NODES[1055](VELOCITY_X,0) = 0.000000; -NODES[1055](VELOCITY_Y,0) = 0.000000; -NODES[1055](VELOCITY_Z,0) = 0.000000; -NODES[1056](VELOCITY_X,0) = 0.000000; -NODES[1056](VELOCITY_Y,0) = 0.000000; -NODES[1056](VELOCITY_Z,0) = 0.000000; -NODES[1057](VELOCITY_X,0) = 0.000000; -NODES[1057](VELOCITY_Y,0) = 0.000000; -NODES[1057](VELOCITY_Z,0) = 0.000000; -NODES[1058](VELOCITY_X,0) = 0.000000; -NODES[1058](VELOCITY_Y,0) = 0.000000; -NODES[1058](VELOCITY_Z,0) = 0.000000; -NODES[1059](VELOCITY_X,0) = 0.000000; -NODES[1059](VELOCITY_Y,0) = 0.000000; -NODES[1059](VELOCITY_Z,0) = 0.000000; -NODES[1060](VELOCITY_X,0) = 0.000000; -NODES[1060](VELOCITY_Y,0) = 0.000000; -NODES[1060](VELOCITY_Z,0) = 0.000000; -NODES[1061](VELOCITY_X,0) = 0.000000; -NODES[1061](VELOCITY_Y,0) = 0.000000; -NODES[1061](VELOCITY_Z,0) = 0.000000; -NODES[1062](VELOCITY_X,0) = 0.000000; -NODES[1062](VELOCITY_Y,0) = 0.000000; -NODES[1062](VELOCITY_Z,0) = 0.000000; -NODES[1063](VELOCITY_X,0) = 0.000000; -NODES[1063](VELOCITY_Y,0) = 0.000000; -NODES[1063](VELOCITY_Z,0) = 0.000000; -NODES[1064](VELOCITY_X,0) = 0.000000; -NODES[1064](VELOCITY_Y,0) = 0.000000; -NODES[1064](VELOCITY_Z,0) = 0.000000; -NODES[1065](VELOCITY_X,0) = 0.000000; -NODES[1065](VELOCITY_Y,0) = 0.000000; -NODES[1065](VELOCITY_Z,0) = 0.000000; -NODES[1066](VELOCITY_X,0) = 0.000000; -NODES[1066](VELOCITY_Y,0) = 0.000000; -NODES[1066](VELOCITY_Z,0) = 0.000000; -NODES[1067](VELOCITY_X,0) = 0.000000; -NODES[1067](VELOCITY_Y,0) = 0.000000; -NODES[1067](VELOCITY_Z,0) = 0.000000; -NODES[1068](VELOCITY_X,0) = 0.000000; -NODES[1068](VELOCITY_Y,0) = 0.000000; -NODES[1068](VELOCITY_Z,0) = 0.000000; -NODES[1069](VELOCITY_X,0) = 0.000000; -NODES[1069](VELOCITY_Y,0) = 0.000000; -NODES[1069](VELOCITY_Z,0) = 0.000000; -NODES[1070](VELOCITY_X,0) = 0.000000; -NODES[1070](VELOCITY_Y,0) = 0.000000; -NODES[1070](VELOCITY_Z,0) = 0.000000; -NODES[1071](VELOCITY_X,0) = 0.000000; -NODES[1071](VELOCITY_Y,0) = 0.000000; -NODES[1071](VELOCITY_Z,0) = 0.000000; -NODES[1072](VELOCITY_X,0) = 0.000000; -NODES[1072](VELOCITY_Y,0) = 0.000000; -NODES[1072](VELOCITY_Z,0) = 0.000000; -NODES[1073](VELOCITY_X,0) = 0.000000; -NODES[1073](VELOCITY_Y,0) = 0.000000; -NODES[1073](VELOCITY_Z,0) = 0.000000; -NODES[1074](VELOCITY_X,0) = 0.000000; -NODES[1074](VELOCITY_Y,0) = 0.000000; -NODES[1074](VELOCITY_Z,0) = 0.000000; -NODES[1075](VELOCITY_X,0) = 0.000000; -NODES[1075](VELOCITY_Y,0) = 0.000000; -NODES[1075](VELOCITY_Z,0) = 0.000000; -NODES[1076](VELOCITY_X,0) = 0.000000; -NODES[1076](VELOCITY_Y,0) = 0.000000; -NODES[1076](VELOCITY_Z,0) = 0.000000; -NODES[1077](VELOCITY_X,0) = 0.000000; -NODES[1077](VELOCITY_Y,0) = 0.000000; -NODES[1077](VELOCITY_Z,0) = 0.000000; -NODES[1078](VELOCITY_X,0) = 0.000000; -NODES[1078](VELOCITY_Y,0) = 0.000000; -NODES[1078](VELOCITY_Z,0) = 0.000000; -NODES[1079](VELOCITY_X,0) = 0.000000; -NODES[1079](VELOCITY_Y,0) = 0.000000; -NODES[1079](VELOCITY_Z,0) = 0.000000; -NODES[1080](VELOCITY_X,0) = 0.000000; -NODES[1080](VELOCITY_Y,0) = 0.000000; -NODES[1080](VELOCITY_Z,0) = 0.000000; -NODES[1081](VELOCITY_X,0) = 0.000000; -NODES[1081](VELOCITY_Y,0) = 0.000000; -NODES[1081](VELOCITY_Z,0) = 0.000000; -NODES[1082](VELOCITY_X,0) = 0.000000; -NODES[1082](VELOCITY_Y,0) = 0.000000; -NODES[1082](VELOCITY_Z,0) = 0.000000; -NODES[1083](VELOCITY_X,0) = 0.000000; -NODES[1083](VELOCITY_Y,0) = 0.000000; -NODES[1083](VELOCITY_Z,0) = 0.000000; -NODES[1084](VELOCITY_X,0) = 0.000000; -NODES[1084](VELOCITY_Y,0) = 0.000000; -NODES[1084](VELOCITY_Z,0) = 0.000000; -NODES[1085](VELOCITY_X,0) = 0.000000; -NODES[1085](VELOCITY_Y,0) = 0.000000; -NODES[1085](VELOCITY_Z,0) = 0.000000; -NODES[1086](VELOCITY_X,0) = 0.000000; -NODES[1086](VELOCITY_Y,0) = 0.000000; -NODES[1086](VELOCITY_Z,0) = 0.000000; -NODES[1087](VELOCITY_X,0) = 0.000000; -NODES[1087](VELOCITY_Y,0) = 0.000000; -NODES[1087](VELOCITY_Z,0) = 0.000000; -NODES[1088](VELOCITY_X,0) = 0.000000; -NODES[1088](VELOCITY_Y,0) = 0.000000; -NODES[1088](VELOCITY_Z,0) = 0.000000; -NODES[1089](VELOCITY_X,0) = 0.000000; -NODES[1089](VELOCITY_Y,0) = 0.000000; -NODES[1089](VELOCITY_Z,0) = 0.000000; -NODES[1090](VELOCITY_X,0) = 0.000000; -NODES[1090](VELOCITY_Y,0) = 0.000000; -NODES[1090](VELOCITY_Z,0) = 0.000000; -NODES[1091](VELOCITY_X,0) = 0.000000; -NODES[1091](VELOCITY_Y,0) = 0.000000; -NODES[1091](VELOCITY_Z,0) = 0.000000; -NODES[1092](VELOCITY_X,0) = 0.000000; -NODES[1092](VELOCITY_Y,0) = 0.000000; -NODES[1092](VELOCITY_Z,0) = 0.000000; -NODES[1093](VELOCITY_X,0) = 0.000000; -NODES[1093](VELOCITY_Y,0) = 0.000000; -NODES[1093](VELOCITY_Z,0) = 0.000000; -NODES[1094](VELOCITY_X,0) = 0.000000; -NODES[1094](VELOCITY_Y,0) = 0.000000; -NODES[1094](VELOCITY_Z,0) = 0.000000; -NODES[1095](VELOCITY_X,0) = 0.000000; -NODES[1095](VELOCITY_Y,0) = 0.000000; -NODES[1095](VELOCITY_Z,0) = 0.000000; -NODES[1096](VELOCITY_X,0) = 0.000000; -NODES[1096](VELOCITY_Y,0) = 0.000000; -NODES[1096](VELOCITY_Z,0) = 0.000000; -NODES[1097](VELOCITY_X,0) = 0.000000; -NODES[1097](VELOCITY_Y,0) = 0.000000; -NODES[1097](VELOCITY_Z,0) = 0.000000; -NODES[1098](VELOCITY_X,0) = 0.000000; -NODES[1098](VELOCITY_Y,0) = 0.000000; -NODES[1098](VELOCITY_Z,0) = 0.000000; -NODES[1099](VELOCITY_X,0) = 0.000000; -NODES[1099](VELOCITY_Y,0) = 0.000000; -NODES[1099](VELOCITY_Z,0) = 0.000000; -NODES[1100](VELOCITY_X,0) = 0.000000; -NODES[1100](VELOCITY_Y,0) = 0.000000; -NODES[1100](VELOCITY_Z,0) = 0.000000; -NODES[1101](VELOCITY_X,0) = 0.000000; -NODES[1101](VELOCITY_Y,0) = 0.000000; -NODES[1101](VELOCITY_Z,0) = 0.000000; -NODES[1102](VELOCITY_X,0) = 0.000000; -NODES[1102](VELOCITY_Y,0) = 0.000000; -NODES[1102](VELOCITY_Z,0) = 0.000000; -NODES[1103](VELOCITY_X,0) = 0.000000; -NODES[1103](VELOCITY_Y,0) = 0.000000; -NODES[1103](VELOCITY_Z,0) = 0.000000; -NODES[1104](VELOCITY_X,0) = 0.000000; -NODES[1104](VELOCITY_Y,0) = 0.000000; -NODES[1104](VELOCITY_Z,0) = 0.000000; -NODES[1105](VELOCITY_X,0) = 0.000000; -NODES[1105](VELOCITY_Y,0) = 0.000000; -NODES[1105](VELOCITY_Z,0) = 0.000000; -NODES[1106](VELOCITY_X,0) = 0.000000; -NODES[1106](VELOCITY_Y,0) = 0.000000; -NODES[1106](VELOCITY_Z,0) = 0.000000; -NODES[1107](VELOCITY_X,0) = 0.000000; -NODES[1107](VELOCITY_Y,0) = 0.000000; -NODES[1107](VELOCITY_Z,0) = 0.000000; -NODES[1108](VELOCITY_X,0) = 0.000000; -NODES[1108](VELOCITY_Y,0) = 0.000000; -NODES[1108](VELOCITY_Z,0) = 0.000000; -NODES[1109](VELOCITY_X,0) = 0.000000; -NODES[1109](VELOCITY_Y,0) = 0.000000; -NODES[1109](VELOCITY_Z,0) = 0.000000; -NODES[1110](VELOCITY_X,0) = 0.000000; -NODES[1110](VELOCITY_Y,0) = 0.000000; -NODES[1110](VELOCITY_Z,0) = 0.000000; -NODES[1111](VELOCITY_X,0) = 0.000000; -NODES[1111](VELOCITY_Y,0) = 0.000000; -NODES[1111](VELOCITY_Z,0) = 0.000000; -NODES[1112](VELOCITY_X,0) = 0.000000; -NODES[1112](VELOCITY_Y,0) = 0.000000; -NODES[1112](VELOCITY_Z,0) = 0.000000; -NODES[1113](VELOCITY_X,0) = 0.000000; -NODES[1113](VELOCITY_Y,0) = 0.000000; -NODES[1113](VELOCITY_Z,0) = 0.000000; -NODES[1114](VELOCITY_X,0) = 0.000000; -NODES[1114](VELOCITY_Y,0) = 0.000000; -NODES[1114](VELOCITY_Z,0) = 0.000000; -NODES[1115](VELOCITY_X,0) = 0.000000; -NODES[1115](VELOCITY_Y,0) = 0.000000; -NODES[1115](VELOCITY_Z,0) = 0.000000; -NODES[1116](VELOCITY_X,0) = 0.000000; -NODES[1116](VELOCITY_Y,0) = 0.000000; -NODES[1116](VELOCITY_Z,0) = 0.000000; -NODES[1117](VELOCITY_X,0) = 0.000000; -NODES[1117](VELOCITY_Y,0) = 0.000000; -NODES[1117](VELOCITY_Z,0) = 0.000000; -NODES[1118](VELOCITY_X,0) = 0.000000; -NODES[1118](VELOCITY_Y,0) = 0.000000; -NODES[1118](VELOCITY_Z,0) = 0.000000; -NODES[1119](VELOCITY_X,0) = 0.000000; -NODES[1119](VELOCITY_Y,0) = 0.000000; -NODES[1119](VELOCITY_Z,0) = 0.000000; -NODES[1120](VELOCITY_X,0) = 0.000000; -NODES[1120](VELOCITY_Y,0) = 0.000000; -NODES[1120](VELOCITY_Z,0) = 0.000000; -NODES[1121](VELOCITY_X,0) = 0.000000; -NODES[1121](VELOCITY_Y,0) = 0.000000; -NODES[1121](VELOCITY_Z,0) = 0.000000; -NODES[1122](VELOCITY_X,0) = 0.000000; -NODES[1122](VELOCITY_Y,0) = 0.000000; -NODES[1122](VELOCITY_Z,0) = 0.000000; -NODES[1123](VELOCITY_X,0) = 0.000000; -NODES[1123](VELOCITY_Y,0) = 0.000000; -NODES[1123](VELOCITY_Z,0) = 0.000000; -NODES[1124](VELOCITY_X,0) = 0.000000; -NODES[1124](VELOCITY_Y,0) = 0.000000; -NODES[1124](VELOCITY_Z,0) = 0.000000; -NODES[1125](VELOCITY_X,0) = 0.000000; -NODES[1125](VELOCITY_Y,0) = 0.000000; -NODES[1125](VELOCITY_Z,0) = 0.000000; -NODES[1126](VELOCITY_X,0) = 0.000000; -NODES[1126](VELOCITY_Y,0) = 0.000000; -NODES[1126](VELOCITY_Z,0) = 0.000000; -NODES[1127](VELOCITY_X,0) = 0.000000; -NODES[1127](VELOCITY_Y,0) = 0.000000; -NODES[1127](VELOCITY_Z,0) = 0.000000; -NODES[1128](VELOCITY_X,0) = 0.000000; -NODES[1128](VELOCITY_Y,0) = 0.000000; -NODES[1128](VELOCITY_Z,0) = 0.000000; -NODES[1129](VELOCITY_X,0) = 0.000000; -NODES[1129](VELOCITY_Y,0) = 0.000000; -NODES[1129](VELOCITY_Z,0) = 0.000000; -NODES[1130](VELOCITY_X,0) = 0.000000; -NODES[1130](VELOCITY_Y,0) = 0.000000; -NODES[1130](VELOCITY_Z,0) = 0.000000; -NODES[1131](VELOCITY_X,0) = 0.000000; -NODES[1131](VELOCITY_Y,0) = 0.000000; -NODES[1131](VELOCITY_Z,0) = 0.000000; -NODES[1132](VELOCITY_X,0) = 0.000000; -NODES[1132](VELOCITY_Y,0) = 0.000000; -NODES[1132](VELOCITY_Z,0) = 0.000000; -NODES[1133](VELOCITY_X,0) = 0.000000; -NODES[1133](VELOCITY_Y,0) = 0.000000; -NODES[1133](VELOCITY_Z,0) = 0.000000; -NODES[1134](VELOCITY_X,0) = 0.000000; -NODES[1134](VELOCITY_Y,0) = 0.000000; -NODES[1134](VELOCITY_Z,0) = 0.000000; -NODES[1135](VELOCITY_X,0) = 0.000000; -NODES[1135](VELOCITY_Y,0) = 0.000000; -NODES[1135](VELOCITY_Z,0) = 0.000000; -NODES[1136](VELOCITY_X,0) = 0.000000; -NODES[1136](VELOCITY_Y,0) = 0.000000; -NODES[1136](VELOCITY_Z,0) = 0.000000; -NODES[1137](VELOCITY_X,0) = 0.000000; -NODES[1137](VELOCITY_Y,0) = 0.000000; -NODES[1137](VELOCITY_Z,0) = 0.000000; -NODES[1138](VELOCITY_X,0) = 0.000000; -NODES[1138](VELOCITY_Y,0) = 0.000000; -NODES[1138](VELOCITY_Z,0) = 0.000000; -NODES[1139](VELOCITY_X,0) = 0.000000; -NODES[1139](VELOCITY_Y,0) = 0.000000; -NODES[1139](VELOCITY_Z,0) = 0.000000; -NODES[1140](VELOCITY_X,0) = 0.000000; -NODES[1140](VELOCITY_Y,0) = 0.000000; -NODES[1140](VELOCITY_Z,0) = 0.000000; -NODES[1141](VELOCITY_X,0) = 0.000000; -NODES[1141](VELOCITY_Y,0) = 0.000000; -NODES[1141](VELOCITY_Z,0) = 0.000000; -NODES[1142](VELOCITY_X,0) = 0.000000; -NODES[1142](VELOCITY_Y,0) = 0.000000; -NODES[1142](VELOCITY_Z,0) = 0.000000; -NODES[1143](VELOCITY_X,0) = 0.000000; -NODES[1143](VELOCITY_Y,0) = 0.000000; -NODES[1143](VELOCITY_Z,0) = 0.000000; -NODES[1144](VELOCITY_X,0) = 0.000000; -NODES[1144](VELOCITY_Y,0) = 0.000000; -NODES[1144](VELOCITY_Z,0) = 0.000000; -NODES[1145](VELOCITY_X,0) = 0.000000; -NODES[1145](VELOCITY_Y,0) = 0.000000; -NODES[1145](VELOCITY_Z,0) = 0.000000; -NODES[1146](VELOCITY_X,0) = 0.000000; -NODES[1146](VELOCITY_Y,0) = 0.000000; -NODES[1146](VELOCITY_Z,0) = 0.000000; -NODES[1147](VELOCITY_X,0) = 0.000000; -NODES[1147](VELOCITY_Y,0) = 0.000000; -NODES[1147](VELOCITY_Z,0) = 0.000000; -NODES[1148](VELOCITY_X,0) = 0.000000; -NODES[1148](VELOCITY_Y,0) = 0.000000; -NODES[1148](VELOCITY_Z,0) = 0.000000; -NODES[1149](VELOCITY_X,0) = 0.000000; -NODES[1149](VELOCITY_Y,0) = 0.000000; -NODES[1149](VELOCITY_Z,0) = 0.000000; -NODES[1150](VELOCITY_X,0) = 0.000000; -NODES[1150](VELOCITY_Y,0) = 0.000000; -NODES[1150](VELOCITY_Z,0) = 0.000000; -NODES[1151](VELOCITY_X,0) = 0.000000; -NODES[1151](VELOCITY_Y,0) = 0.000000; -NODES[1151](VELOCITY_Z,0) = 0.000000; -NODES[1152](VELOCITY_X,0) = 0.000000; -NODES[1152](VELOCITY_Y,0) = 0.000000; -NODES[1152](VELOCITY_Z,0) = 0.000000; -NODES[1153](VELOCITY_X,0) = 0.000000; -NODES[1153](VELOCITY_Y,0) = 0.000000; -NODES[1153](VELOCITY_Z,0) = 0.000000; -NODES[1154](VELOCITY_X,0) = 0.000000; -NODES[1154](VELOCITY_Y,0) = 0.000000; -NODES[1154](VELOCITY_Z,0) = 0.000000; -NODES[1155](VELOCITY_X,0) = 0.000000; -NODES[1155](VELOCITY_Y,0) = 0.000000; -NODES[1155](VELOCITY_Z,0) = 0.000000; -NODES[1156](VELOCITY_X,0) = 0.000000; -NODES[1156](VELOCITY_Y,0) = 0.000000; -NODES[1156](VELOCITY_Z,0) = 0.000000; -NODES[1157](VELOCITY_X,0) = 0.000000; -NODES[1157](VELOCITY_Y,0) = 0.000000; -NODES[1157](VELOCITY_Z,0) = 0.000000; -NODES[1158](VELOCITY_X,0) = 0.000000; -NODES[1158](VELOCITY_Y,0) = 0.000000; -NODES[1158](VELOCITY_Z,0) = 0.000000; -NODES[1159](VELOCITY_X,0) = 0.000000; -NODES[1159](VELOCITY_Y,0) = 0.000000; -NODES[1159](VELOCITY_Z,0) = 0.000000; -NODES[1160](VELOCITY_X,0) = 0.000000; -NODES[1160](VELOCITY_Y,0) = 0.000000; -NODES[1160](VELOCITY_Z,0) = 0.000000; -NODES[1161](VELOCITY_X,0) = 0.000000; -NODES[1161](VELOCITY_Y,0) = 0.000000; -NODES[1161](VELOCITY_Z,0) = 0.000000; -NODES[1162](VELOCITY_X,0) = 0.000000; -NODES[1162](VELOCITY_Y,0) = 0.000000; -NODES[1162](VELOCITY_Z,0) = 0.000000; -NODES[1163](VELOCITY_X,0) = 0.000000; -NODES[1163](VELOCITY_Y,0) = 0.000000; -NODES[1163](VELOCITY_Z,0) = 0.000000; -NODES[1164](VELOCITY_X,0) = 0.000000; -NODES[1164](VELOCITY_Y,0) = 0.000000; -NODES[1164](VELOCITY_Z,0) = 0.000000; -NODES[1165](VELOCITY_X,0) = 0.000000; -NODES[1165](VELOCITY_Y,0) = 0.000000; -NODES[1165](VELOCITY_Z,0) = 0.000000; -NODES[1166](VELOCITY_X,0) = 0.000000; -NODES[1166](VELOCITY_Y,0) = 0.000000; -NODES[1166](VELOCITY_Z,0) = 0.000000; -NODES[1167](VELOCITY_X,0) = 0.000000; -NODES[1167](VELOCITY_Y,0) = 0.000000; -NODES[1167](VELOCITY_Z,0) = 0.000000; -NODES[1168](VELOCITY_X,0) = 0.000000; -NODES[1168](VELOCITY_Y,0) = 0.000000; -NODES[1168](VELOCITY_Z,0) = 0.000000; -NODES[1169](VELOCITY_X,0) = 0.000000; -NODES[1169](VELOCITY_Y,0) = 0.000000; -NODES[1169](VELOCITY_Z,0) = 0.000000; -NODES[1170](VELOCITY_X,0) = 0.000000; -NODES[1170](VELOCITY_Y,0) = 0.000000; -NODES[1170](VELOCITY_Z,0) = 0.000000; -NODES[1171](VELOCITY_X,0) = 0.000000; -NODES[1171](VELOCITY_Y,0) = 0.000000; -NODES[1171](VELOCITY_Z,0) = 0.000000; -NODES[1172](VELOCITY_X,0) = 0.000000; -NODES[1172](VELOCITY_Y,0) = 0.000000; -NODES[1172](VELOCITY_Z,0) = 0.000000; -NODES[1173](VELOCITY_X,0) = 0.000000; -NODES[1173](VELOCITY_Y,0) = 0.000000; -NODES[1173](VELOCITY_Z,0) = 0.000000; -NODES[1174](VELOCITY_X,0) = 0.000000; -NODES[1174](VELOCITY_Y,0) = 0.000000; -NODES[1174](VELOCITY_Z,0) = 0.000000; -NODES[1175](VELOCITY_X,0) = 0.000000; -NODES[1175](VELOCITY_Y,0) = 0.000000; -NODES[1175](VELOCITY_Z,0) = 0.000000; -NODES[1176](VELOCITY_X,0) = 0.000000; -NODES[1176](VELOCITY_Y,0) = 0.000000; -NODES[1176](VELOCITY_Z,0) = 0.000000; -NODES[1177](VELOCITY_X,0) = 0.000000; -NODES[1177](VELOCITY_Y,0) = 0.000000; -NODES[1177](VELOCITY_Z,0) = 0.000000; -NODES[1178](VELOCITY_X,0) = 0.000000; -NODES[1178](VELOCITY_Y,0) = 0.000000; -NODES[1178](VELOCITY_Z,0) = 0.000000; -NODES[1179](VELOCITY_X,0) = 0.000000; -NODES[1179](VELOCITY_Y,0) = 0.000000; -NODES[1179](VELOCITY_Z,0) = 0.000000; -NODES[1180](VELOCITY_X,0) = 0.000000; -NODES[1180](VELOCITY_Y,0) = 0.000000; -NODES[1180](VELOCITY_Z,0) = 0.000000; -NODES[1181](VELOCITY_X,0) = 0.000000; -NODES[1181](VELOCITY_Y,0) = 0.000000; -NODES[1181](VELOCITY_Z,0) = 0.000000; -NODES[1182](VELOCITY_X,0) = 0.000000; -NODES[1182](VELOCITY_Y,0) = 0.000000; -NODES[1182](VELOCITY_Z,0) = 0.000000; -NODES[1183](VELOCITY_X,0) = 0.000000; -NODES[1183](VELOCITY_Y,0) = 0.000000; -NODES[1183](VELOCITY_Z,0) = 0.000000; -NODES[1184](VELOCITY_X,0) = 0.000000; -NODES[1184](VELOCITY_Y,0) = 0.000000; -NODES[1184](VELOCITY_Z,0) = 0.000000; -NODES[1185](VELOCITY_X,0) = 0.000000; -NODES[1185](VELOCITY_Y,0) = 0.000000; -NODES[1185](VELOCITY_Z,0) = 0.000000; -NODES[1186](VELOCITY_X,0) = 0.000000; -NODES[1186](VELOCITY_Y,0) = 0.000000; -NODES[1186](VELOCITY_Z,0) = 0.000000; -NODES[1187](VELOCITY_X,0) = 0.000000; -NODES[1187](VELOCITY_Y,0) = 0.000000; -NODES[1187](VELOCITY_Z,0) = 0.000000; -NODES[1188](VELOCITY_X,0) = 0.000000; -NODES[1188](VELOCITY_Y,0) = 0.000000; -NODES[1188](VELOCITY_Z,0) = 0.000000; -NODES[1189](VELOCITY_X,0) = 0.000000; -NODES[1189](VELOCITY_Y,0) = 0.000000; -NODES[1189](VELOCITY_Z,0) = 0.000000; -NODES[1190](VELOCITY_X,0) = 0.000000; -NODES[1190](VELOCITY_Y,0) = 0.000000; -NODES[1190](VELOCITY_Z,0) = 0.000000; -NODES[1191](VELOCITY_X,0) = 0.000000; -NODES[1191](VELOCITY_Y,0) = 0.000000; -NODES[1191](VELOCITY_Z,0) = 0.000000; -NODES[1192](VELOCITY_X,0) = 0.000000; -NODES[1192](VELOCITY_Y,0) = 0.000000; -NODES[1192](VELOCITY_Z,0) = 0.000000; -NODES[1193](VELOCITY_X,0) = 0.000000; -NODES[1193](VELOCITY_Y,0) = 0.000000; -NODES[1193](VELOCITY_Z,0) = 0.000000; -NODES[1194](VELOCITY_X,0) = 0.000000; -NODES[1194](VELOCITY_Y,0) = 0.000000; -NODES[1194](VELOCITY_Z,0) = 0.000000; -NODES[1195](VELOCITY_X,0) = 0.000000; -NODES[1195](VELOCITY_Y,0) = 0.000000; -NODES[1195](VELOCITY_Z,0) = 0.000000; -NODES[1196](VELOCITY_X,0) = 0.000000; -NODES[1196](VELOCITY_Y,0) = 0.000000; -NODES[1196](VELOCITY_Z,0) = 0.000000; -NODES[1197](VELOCITY_X,0) = 0.000000; -NODES[1197](VELOCITY_Y,0) = 0.000000; -NODES[1197](VELOCITY_Z,0) = 0.000000; -NODES[1198](VELOCITY_X,0) = 0.000000; -NODES[1198](VELOCITY_Y,0) = 0.000000; -NODES[1198](VELOCITY_Z,0) = 0.000000; -NODES[1199](VELOCITY_X,0) = 0.000000; -NODES[1199](VELOCITY_Y,0) = 0.000000; -NODES[1199](VELOCITY_Z,0) = 0.000000; -NODES[1200](VELOCITY_X,0) = 0.000000; -NODES[1200](VELOCITY_Y,0) = 0.000000; -NODES[1200](VELOCITY_Z,0) = 0.000000; -NODES[1201](VELOCITY_X,0) = 0.000000; -NODES[1201](VELOCITY_Y,0) = 0.000000; -NODES[1201](VELOCITY_Z,0) = 0.000000; -NODES[1202](VELOCITY_X,0) = 0.000000; -NODES[1202](VELOCITY_Y,0) = 0.000000; -NODES[1202](VELOCITY_Z,0) = 0.000000; -NODES[1203](VELOCITY_X,0) = 0.000000; -NODES[1203](VELOCITY_Y,0) = 0.000000; -NODES[1203](VELOCITY_Z,0) = 0.000000; -NODES[1204](VELOCITY_X,0) = 0.000000; -NODES[1204](VELOCITY_Y,0) = 0.000000; -NODES[1204](VELOCITY_Z,0) = 0.000000; -NODES[1205](VELOCITY_X,0) = 0.000000; -NODES[1205](VELOCITY_Y,0) = 0.000000; -NODES[1205](VELOCITY_Z,0) = 0.000000; -NODES[1206](VELOCITY_X,0) = 0.000000; -NODES[1206](VELOCITY_Y,0) = 0.000000; -NODES[1206](VELOCITY_Z,0) = 0.000000; -NODES[1207](VELOCITY_X,0) = 0.000000; -NODES[1207](VELOCITY_Y,0) = 0.000000; -NODES[1207](VELOCITY_Z,0) = 0.000000; -NODES[1208](VELOCITY_X,0) = 0.000000; -NODES[1208](VELOCITY_Y,0) = 0.000000; -NODES[1208](VELOCITY_Z,0) = 0.000000; -NODES[1209](VELOCITY_X,0) = 0.000000; -NODES[1209](VELOCITY_Y,0) = 0.000000; -NODES[1209](VELOCITY_Z,0) = 0.000000; -NODES[1210](VELOCITY_X,0) = 0.000000; -NODES[1210](VELOCITY_Y,0) = 0.000000; -NODES[1210](VELOCITY_Z,0) = 0.000000; -NODES[1211](VELOCITY_X,0) = 0.000000; -NODES[1211](VELOCITY_Y,0) = 0.000000; -NODES[1211](VELOCITY_Z,0) = 0.000000; -NODES[1212](VELOCITY_X,0) = 0.000000; -NODES[1212](VELOCITY_Y,0) = 0.000000; -NODES[1212](VELOCITY_Z,0) = 0.000000; -NODES[1213](VELOCITY_X,0) = 0.000000; -NODES[1213](VELOCITY_Y,0) = 0.000000; -NODES[1213](VELOCITY_Z,0) = 0.000000; -NODES[1214](VELOCITY_X,0) = 0.000000; -NODES[1214](VELOCITY_Y,0) = 0.000000; -NODES[1214](VELOCITY_Z,0) = 0.000000; -NODES[1215](VELOCITY_X,0) = 0.000000; -NODES[1215](VELOCITY_Y,0) = 0.000000; -NODES[1215](VELOCITY_Z,0) = 0.000000; -NODES[1216](VELOCITY_X,0) = 0.000000; -NODES[1216](VELOCITY_Y,0) = 0.000000; -NODES[1216](VELOCITY_Z,0) = 0.000000; -NODES[1217](VELOCITY_X,0) = 0.000000; -NODES[1217](VELOCITY_Y,0) = 0.000000; -NODES[1217](VELOCITY_Z,0) = 0.000000; -NODES[1218](VELOCITY_X,0) = 0.000000; -NODES[1218](VELOCITY_Y,0) = 0.000000; -NODES[1218](VELOCITY_Z,0) = 0.000000; -NODES[1219](VELOCITY_X,0) = 0.000000; -NODES[1219](VELOCITY_Y,0) = 0.000000; -NODES[1219](VELOCITY_Z,0) = 0.000000; -NODES[1220](VELOCITY_X,0) = 0.000000; -NODES[1220](VELOCITY_Y,0) = 0.000000; -NODES[1220](VELOCITY_Z,0) = 0.000000; -NODES[1221](VELOCITY_X,0) = 0.000000; -NODES[1221](VELOCITY_Y,0) = 0.000000; -NODES[1221](VELOCITY_Z,0) = 0.000000; -NODES[1222](VELOCITY_X,0) = 0.000000; -NODES[1222](VELOCITY_Y,0) = 0.000000; -NODES[1222](VELOCITY_Z,0) = 0.000000; -NODES[1223](VELOCITY_X,0) = 0.000000; -NODES[1223](VELOCITY_Y,0) = 0.000000; -NODES[1223](VELOCITY_Z,0) = 0.000000; -NODES[1224](VELOCITY_X,0) = 0.000000; -NODES[1224](VELOCITY_Y,0) = 0.000000; -NODES[1224](VELOCITY_Z,0) = 0.000000; -NODES[1225](VELOCITY_X,0) = 0.000000; -NODES[1225](VELOCITY_Y,0) = 0.000000; -NODES[1225](VELOCITY_Z,0) = 0.000000; -NODES[1226](VELOCITY_X,0) = 0.000000; -NODES[1226](VELOCITY_Y,0) = 0.000000; -NODES[1226](VELOCITY_Z,0) = 0.000000; -NODES[1227](VELOCITY_X,0) = 0.000000; -NODES[1227](VELOCITY_Y,0) = 0.000000; -NODES[1227](VELOCITY_Z,0) = 0.000000; -NODES[1228](VELOCITY_X,0) = 0.000000; -NODES[1228](VELOCITY_Y,0) = 0.000000; -NODES[1228](VELOCITY_Z,0) = 0.000000; -NODES[1229](VELOCITY_X,0) = 0.000000; -NODES[1229](VELOCITY_Y,0) = 0.000000; -NODES[1229](VELOCITY_Z,0) = 0.000000; -NODES[1230](VELOCITY_X,0) = 0.000000; -NODES[1230](VELOCITY_Y,0) = 0.000000; -NODES[1230](VELOCITY_Z,0) = 0.000000; -NODES[1231](VELOCITY_X,0) = 0.000000; -NODES[1231](VELOCITY_Y,0) = 0.000000; -NODES[1231](VELOCITY_Z,0) = 0.000000; -NODES[1232](VELOCITY_X,0) = 0.000000; -NODES[1232](VELOCITY_Y,0) = 0.000000; -NODES[1232](VELOCITY_Z,0) = 0.000000; -NODES[1233](VELOCITY_X,0) = 0.000000; -NODES[1233](VELOCITY_Y,0) = 0.000000; -NODES[1233](VELOCITY_Z,0) = 0.000000; -NODES[1234](VELOCITY_X,0) = 0.000000; -NODES[1234](VELOCITY_Y,0) = 0.000000; -NODES[1234](VELOCITY_Z,0) = 0.000000; -NODES[1235](VELOCITY_X,0) = 0.000000; -NODES[1235](VELOCITY_Y,0) = 0.000000; -NODES[1235](VELOCITY_Z,0) = 0.000000; -NODES[1236](VELOCITY_X,0) = 0.000000; -NODES[1236](VELOCITY_Y,0) = 0.000000; -NODES[1236](VELOCITY_Z,0) = 0.000000; -NODES[1237](VELOCITY_X,0) = 0.000000; -NODES[1237](VELOCITY_Y,0) = 0.000000; -NODES[1237](VELOCITY_Z,0) = 0.000000; -NODES[1238](VELOCITY_X,0) = 0.000000; -NODES[1238](VELOCITY_Y,0) = 0.000000; -NODES[1238](VELOCITY_Z,0) = 0.000000; -NODES[1239](VELOCITY_X,0) = 0.000000; -NODES[1239](VELOCITY_Y,0) = 0.000000; -NODES[1239](VELOCITY_Z,0) = 0.000000; -NODES[1240](VELOCITY_X,0) = 0.000000; -NODES[1240](VELOCITY_Y,0) = 0.000000; -NODES[1240](VELOCITY_Z,0) = 0.000000; -NODES[1241](VELOCITY_X,0) = 0.000000; -NODES[1241](VELOCITY_Y,0) = 0.000000; -NODES[1241](VELOCITY_Z,0) = 0.000000; -NODES[1242](VELOCITY_X,0) = 0.000000; -NODES[1242](VELOCITY_Y,0) = 0.000000; -NODES[1242](VELOCITY_Z,0) = 0.000000; -NODES[1243](VELOCITY_X,0) = 0.000000; -NODES[1243](VELOCITY_Y,0) = 0.000000; -NODES[1243](VELOCITY_Z,0) = 0.000000; -NODES[1244](VELOCITY_X,0) = 0.000000; -NODES[1244](VELOCITY_Y,0) = 0.000000; -NODES[1244](VELOCITY_Z,0) = 0.000000; -NODES[1245](VELOCITY_X,0) = 0.000000; -NODES[1245](VELOCITY_Y,0) = 0.000000; -NODES[1245](VELOCITY_Z,0) = 0.000000; -NODES[1246](VELOCITY_X,0) = 0.000000; -NODES[1246](VELOCITY_Y,0) = 0.000000; -NODES[1246](VELOCITY_Z,0) = 0.000000; -NODES[1247](VELOCITY_X,0) = 0.000000; -NODES[1247](VELOCITY_Y,0) = 0.000000; -NODES[1247](VELOCITY_Z,0) = 0.000000; -NODES[1248](VELOCITY_X,0) = 0.000000; -NODES[1248](VELOCITY_Y,0) = 0.000000; -NODES[1248](VELOCITY_Z,0) = 0.000000; -NODES[1249](VELOCITY_X,0) = 0.000000; -NODES[1249](VELOCITY_Y,0) = 0.000000; -NODES[1249](VELOCITY_Z,0) = 0.000000; -NODES[1250](VELOCITY_X,0) = 0.000000; -NODES[1250](VELOCITY_Y,0) = 0.000000; -NODES[1250](VELOCITY_Z,0) = 0.000000; -NODES[1251](VELOCITY_X,0) = 0.000000; -NODES[1251](VELOCITY_Y,0) = 0.000000; -NODES[1251](VELOCITY_Z,0) = 0.000000; -NODES[1252](VELOCITY_X,0) = 0.000000; -NODES[1252](VELOCITY_Y,0) = 0.000000; -NODES[1252](VELOCITY_Z,0) = 0.000000; -NODES[1253](VELOCITY_X,0) = 0.000000; -NODES[1253](VELOCITY_Y,0) = 0.000000; -NODES[1253](VELOCITY_Z,0) = 0.000000; -NODES[1254](VELOCITY_X,0) = 0.000000; -NODES[1254](VELOCITY_Y,0) = 0.000000; -NODES[1254](VELOCITY_Z,0) = 0.000000; -NODES[1255](VELOCITY_X,0) = 0.000000; -NODES[1255](VELOCITY_Y,0) = 0.000000; -NODES[1255](VELOCITY_Z,0) = 0.000000; -NODES[1256](VELOCITY_X,0) = 0.000000; -NODES[1256](VELOCITY_Y,0) = 0.000000; -NODES[1256](VELOCITY_Z,0) = 0.000000; -NODES[1257](VELOCITY_X,0) = 0.000000; -NODES[1257](VELOCITY_Y,0) = 0.000000; -NODES[1257](VELOCITY_Z,0) = 0.000000; -NODES[1258](VELOCITY_X,0) = 0.000000; -NODES[1258](VELOCITY_Y,0) = 0.000000; -NODES[1258](VELOCITY_Z,0) = 0.000000; -NODES[1259](VELOCITY_X,0) = 0.000000; -NODES[1259](VELOCITY_Y,0) = 0.000000; -NODES[1259](VELOCITY_Z,0) = 0.000000; -NODES[1260](VELOCITY_X,0) = 0.000000; -NODES[1260](VELOCITY_Y,0) = 0.000000; -NODES[1260](VELOCITY_Z,0) = 0.000000; -NODES[1261](VELOCITY_X,0) = 0.000000; -NODES[1261](VELOCITY_Y,0) = 0.000000; -NODES[1261](VELOCITY_Z,0) = 0.000000; -NODES[1262](VELOCITY_X,0) = 0.000000; -NODES[1262](VELOCITY_Y,0) = 0.000000; -NODES[1262](VELOCITY_Z,0) = 0.000000; -NODES[1263](VELOCITY_X,0) = 0.000000; -NODES[1263](VELOCITY_Y,0) = 0.000000; -NODES[1263](VELOCITY_Z,0) = 0.000000; -NODES[1264](VELOCITY_X,0) = 0.000000; -NODES[1264](VELOCITY_Y,0) = 0.000000; -NODES[1264](VELOCITY_Z,0) = 0.000000; -NODES[1265](VELOCITY_X,0) = 0.000000; -NODES[1265](VELOCITY_Y,0) = 0.000000; -NODES[1265](VELOCITY_Z,0) = 0.000000; -NODES[1266](VELOCITY_X,0) = 0.000000; -NODES[1266](VELOCITY_Y,0) = 0.000000; -NODES[1266](VELOCITY_Z,0) = 0.000000; -NODES[1267](VELOCITY_X,0) = 0.000000; -NODES[1267](VELOCITY_Y,0) = 0.000000; -NODES[1267](VELOCITY_Z,0) = 0.000000; -NODES[1268](VELOCITY_X,0) = 0.000000; -NODES[1268](VELOCITY_Y,0) = 0.000000; -NODES[1268](VELOCITY_Z,0) = 0.000000; -NODES[1269](VELOCITY_X,0) = 0.000000; -NODES[1269](VELOCITY_Y,0) = 0.000000; -NODES[1269](VELOCITY_Z,0) = 0.000000; -NODES[1270](VELOCITY_X,0) = 0.000000; -NODES[1270](VELOCITY_Y,0) = 0.000000; -NODES[1270](VELOCITY_Z,0) = 0.000000; -NODES[1271](VELOCITY_X,0) = 0.000000; -NODES[1271](VELOCITY_Y,0) = 0.000000; -NODES[1271](VELOCITY_Z,0) = 0.000000; -NODES[1272](VELOCITY_X,0) = 0.000000; -NODES[1272](VELOCITY_Y,0) = 0.000000; -NODES[1272](VELOCITY_Z,0) = 0.000000; -NODES[1273](VELOCITY_X,0) = 0.000000; -NODES[1273](VELOCITY_Y,0) = 0.000000; -NODES[1273](VELOCITY_Z,0) = 0.000000; -NODES[1274](VELOCITY_X,0) = 0.000000; -NODES[1274](VELOCITY_Y,0) = 0.000000; -NODES[1274](VELOCITY_Z,0) = 0.000000; -NODES[1275](VELOCITY_X,0) = 0.000000; -NODES[1275](VELOCITY_Y,0) = 0.000000; -NODES[1275](VELOCITY_Z,0) = 0.000000; -NODES[1276](VELOCITY_X,0) = 0.000000; -NODES[1276](VELOCITY_Y,0) = 0.000000; -NODES[1276](VELOCITY_Z,0) = 0.000000; -NODES[1277](VELOCITY_X,0) = 0.000000; -NODES[1277](VELOCITY_Y,0) = 0.000000; -NODES[1277](VELOCITY_Z,0) = 0.000000; -NODES[1278](VELOCITY_X,0) = 0.000000; -NODES[1278](VELOCITY_Y,0) = 0.000000; -NODES[1278](VELOCITY_Z,0) = 0.000000; -NODES[1279](VELOCITY_X,0) = 0.000000; -NODES[1279](VELOCITY_Y,0) = 0.000000; -NODES[1279](VELOCITY_Z,0) = 0.000000; -NODES[1280](VELOCITY_X,0) = 0.000000; -NODES[1280](VELOCITY_Y,0) = 0.000000; -NODES[1280](VELOCITY_Z,0) = 0.000000; -NODES[1281](VELOCITY_X,0) = 0.000000; -NODES[1281](VELOCITY_Y,0) = 0.000000; -NODES[1281](VELOCITY_Z,0) = 0.000000; -NODES[1282](VELOCITY_X,0) = 0.000000; -NODES[1282](VELOCITY_Y,0) = 0.000000; -NODES[1282](VELOCITY_Z,0) = 0.000000; -NODES[1283](VELOCITY_X,0) = 0.000000; -NODES[1283](VELOCITY_Y,0) = 0.000000; -NODES[1283](VELOCITY_Z,0) = 0.000000; -NODES[1284](VELOCITY_X,0) = 0.000000; -NODES[1284](VELOCITY_Y,0) = 0.000000; -NODES[1284](VELOCITY_Z,0) = 0.000000; -NODES[1285](VELOCITY_X,0) = 0.000000; -NODES[1285](VELOCITY_Y,0) = 0.000000; -NODES[1285](VELOCITY_Z,0) = 0.000000; -NODES[1286](VELOCITY_X,0) = 0.000000; -NODES[1286](VELOCITY_Y,0) = 0.000000; -NODES[1286](VELOCITY_Z,0) = 0.000000; -NODES[1287](VELOCITY_X,0) = 0.000000; -NODES[1287](VELOCITY_Y,0) = 0.000000; -NODES[1287](VELOCITY_Z,0) = 0.000000; -NODES[1288](VELOCITY_X,0) = 0.000000; -NODES[1288](VELOCITY_Y,0) = 0.000000; -NODES[1288](VELOCITY_Z,0) = 0.000000; -NODES[1289](VELOCITY_X,0) = 0.000000; -NODES[1289](VELOCITY_Y,0) = 0.000000; -NODES[1289](VELOCITY_Z,0) = 0.000000; -NODES[1290](VELOCITY_X,0) = 0.000000; -NODES[1290](VELOCITY_Y,0) = 0.000000; -NODES[1290](VELOCITY_Z,0) = 0.000000; -NODES[1291](VELOCITY_X,0) = 0.000000; -NODES[1291](VELOCITY_Y,0) = 0.000000; -NODES[1291](VELOCITY_Z,0) = 0.000000; -NODES[1292](VELOCITY_X,0) = 0.000000; -NODES[1292](VELOCITY_Y,0) = 0.000000; -NODES[1292](VELOCITY_Z,0) = 0.000000; -NODES[1293](VELOCITY_X,0) = 0.000000; -NODES[1293](VELOCITY_Y,0) = 0.000000; -NODES[1293](VELOCITY_Z,0) = 0.000000; -NODES[1294](VELOCITY_X,0) = 0.000000; -NODES[1294](VELOCITY_Y,0) = 0.000000; -NODES[1294](VELOCITY_Z,0) = 0.000000; -NODES[1295](VELOCITY_X,0) = 0.000000; -NODES[1295](VELOCITY_Y,0) = 0.000000; -NODES[1295](VELOCITY_Z,0) = 0.000000; -NODES[1296](VELOCITY_X,0) = 0.000000; -NODES[1296](VELOCITY_Y,0) = 0.000000; -NODES[1296](VELOCITY_Z,0) = 0.000000; -NODES[1297](VELOCITY_X,0) = 0.000000; -NODES[1297](VELOCITY_Y,0) = 0.000000; -NODES[1297](VELOCITY_Z,0) = 0.000000; -NODES[1298](VELOCITY_X,0) = 0.000000; -NODES[1298](VELOCITY_Y,0) = 0.000000; -NODES[1298](VELOCITY_Z,0) = 0.000000; -NODES[1299](VELOCITY_X,0) = 0.000000; -NODES[1299](VELOCITY_Y,0) = 0.000000; -NODES[1299](VELOCITY_Z,0) = 0.000000; -NODES[1300](VELOCITY_X,0) = 0.000000; -NODES[1300](VELOCITY_Y,0) = 0.000000; -NODES[1300](VELOCITY_Z,0) = 0.000000; -NODES[1301](VELOCITY_X,0) = 0.000000; -NODES[1301](VELOCITY_Y,0) = 0.000000; -NODES[1301](VELOCITY_Z,0) = 0.000000; -NODES[1302](VELOCITY_X,0) = 0.000000; -NODES[1302](VELOCITY_Y,0) = 0.000000; -NODES[1302](VELOCITY_Z,0) = 0.000000; -NODES[1303](VELOCITY_X,0) = 0.000000; -NODES[1303](VELOCITY_Y,0) = 0.000000; -NODES[1303](VELOCITY_Z,0) = 0.000000; -NODES[1304](VELOCITY_X,0) = 0.000000; -NODES[1304](VELOCITY_Y,0) = 0.000000; -NODES[1304](VELOCITY_Z,0) = 0.000000; -NODES[1305](VELOCITY_X,0) = 0.000000; -NODES[1305](VELOCITY_Y,0) = 0.000000; -NODES[1305](VELOCITY_Z,0) = 0.000000; -NODES[1306](VELOCITY_X,0) = 0.000000; -NODES[1306](VELOCITY_Y,0) = 0.000000; -NODES[1306](VELOCITY_Z,0) = 0.000000; -NODES[1307](VELOCITY_X,0) = 0.000000; -NODES[1307](VELOCITY_Y,0) = 0.000000; -NODES[1307](VELOCITY_Z,0) = 0.000000; -NODES[1308](VELOCITY_X,0) = 0.000000; -NODES[1308](VELOCITY_Y,0) = 0.000000; -NODES[1308](VELOCITY_Z,0) = 0.000000; -NODES[1309](VELOCITY_X,0) = 0.000000; -NODES[1309](VELOCITY_Y,0) = 0.000000; -NODES[1309](VELOCITY_Z,0) = 0.000000; -NODES[1310](VELOCITY_X,0) = 0.000000; -NODES[1310](VELOCITY_Y,0) = 0.000000; -NODES[1310](VELOCITY_Z,0) = 0.000000; -NODES[1311](VELOCITY_X,0) = 0.000000; -NODES[1311](VELOCITY_Y,0) = 0.000000; -NODES[1311](VELOCITY_Z,0) = 0.000000; -NODES[1312](VELOCITY_X,0) = 0.000000; -NODES[1312](VELOCITY_Y,0) = 0.000000; -NODES[1312](VELOCITY_Z,0) = 0.000000; -NODES[1313](VELOCITY_X,0) = 0.000000; -NODES[1313](VELOCITY_Y,0) = 0.000000; -NODES[1313](VELOCITY_Z,0) = 0.000000; -NODES[1314](VELOCITY_X,0) = 0.000000; -NODES[1314](VELOCITY_Y,0) = 0.000000; -NODES[1314](VELOCITY_Z,0) = 0.000000; -NODES[1315](VELOCITY_X,0) = 0.000000; -NODES[1315](VELOCITY_Y,0) = 0.000000; -NODES[1315](VELOCITY_Z,0) = 0.000000; -NODES[1316](VELOCITY_X,0) = 0.000000; -NODES[1316](VELOCITY_Y,0) = 0.000000; -NODES[1316](VELOCITY_Z,0) = 0.000000; -NODES[1317](VELOCITY_X,0) = 0.000000; -NODES[1317](VELOCITY_Y,0) = 0.000000; -NODES[1317](VELOCITY_Z,0) = 0.000000; -NODES[1318](VELOCITY_X,0) = 0.000000; -NODES[1318](VELOCITY_Y,0) = 0.000000; -NODES[1318](VELOCITY_Z,0) = 0.000000; -NODES[1319](VELOCITY_X,0) = 0.000000; -NODES[1319](VELOCITY_Y,0) = 0.000000; -NODES[1319](VELOCITY_Z,0) = 0.000000; -NODES[1320](VELOCITY_X,0) = 0.000000; -NODES[1320](VELOCITY_Y,0) = 0.000000; -NODES[1320](VELOCITY_Z,0) = 0.000000; -NODES[1321](VELOCITY_X,0) = 0.000000; -NODES[1321](VELOCITY_Y,0) = 0.000000; -NODES[1321](VELOCITY_Z,0) = 0.000000; -NODES[1322](VELOCITY_X,0) = 0.000000; -NODES[1322](VELOCITY_Y,0) = 0.000000; -NODES[1322](VELOCITY_Z,0) = 0.000000; -NODES[1323](VELOCITY_X,0) = 0.000000; -NODES[1323](VELOCITY_Y,0) = 0.000000; -NODES[1323](VELOCITY_Z,0) = 0.000000; -NODES[1324](VELOCITY_X,0) = 0.000000; -NODES[1324](VELOCITY_Y,0) = 0.000000; -NODES[1324](VELOCITY_Z,0) = 0.000000; -NODES[1325](VELOCITY_X,0) = 0.000000; -NODES[1325](VELOCITY_Y,0) = 0.000000; -NODES[1325](VELOCITY_Z,0) = 0.000000; -NODES[1326](VELOCITY_X,0) = 0.000000; -NODES[1326](VELOCITY_Y,0) = 0.000000; -NODES[1326](VELOCITY_Z,0) = 0.000000; -NODES[1327](VELOCITY_X,0) = 0.000000; -NODES[1327](VELOCITY_Y,0) = 0.000000; -NODES[1327](VELOCITY_Z,0) = 0.000000; -NODES[1328](VELOCITY_X,0) = 0.000000; -NODES[1328](VELOCITY_Y,0) = 0.000000; -NODES[1328](VELOCITY_Z,0) = 0.000000; -NODES[1329](VELOCITY_X,0) = 0.000000; -NODES[1329](VELOCITY_Y,0) = 0.000000; -NODES[1329](VELOCITY_Z,0) = 0.000000; -NODES[1330](VELOCITY_X,0) = 0.000000; -NODES[1330](VELOCITY_Y,0) = 0.000000; -NODES[1330](VELOCITY_Z,0) = 0.000000; -NODES[1331](VELOCITY_X,0) = 0.000000; -NODES[1331](VELOCITY_Y,0) = 0.000000; -NODES[1331](VELOCITY_Z,0) = 0.000000; -NODES[1332](VELOCITY_X,0) = 0.000000; -NODES[1332](VELOCITY_Y,0) = 0.000000; -NODES[1332](VELOCITY_Z,0) = 0.000000; -NODES[1333](VELOCITY_X,0) = 0.000000; -NODES[1333](VELOCITY_Y,0) = 0.000000; -NODES[1333](VELOCITY_Z,0) = 0.000000; -NODES[1334](VELOCITY_X,0) = 0.000000; -NODES[1334](VELOCITY_Y,0) = 0.000000; -NODES[1334](VELOCITY_Z,0) = 0.000000; -NODES[1335](VELOCITY_X,0) = 0.000000; -NODES[1335](VELOCITY_Y,0) = 0.000000; -NODES[1335](VELOCITY_Z,0) = 0.000000; -NODES[1336](VELOCITY_X,0) = 0.000000; -NODES[1336](VELOCITY_Y,0) = 0.000000; -NODES[1336](VELOCITY_Z,0) = 0.000000; -NODES[1337](VELOCITY_X,0) = 0.000000; -NODES[1337](VELOCITY_Y,0) = 0.000000; -NODES[1337](VELOCITY_Z,0) = 0.000000; -NODES[1338](VELOCITY_X,0) = 0.000000; -NODES[1338](VELOCITY_Y,0) = 0.000000; -NODES[1338](VELOCITY_Z,0) = 0.000000; -NODES[1339](VELOCITY_X,0) = 0.000000; -NODES[1339](VELOCITY_Y,0) = 0.000000; -NODES[1339](VELOCITY_Z,0) = 0.000000; -NODES[1340](VELOCITY_X,0) = 0.000000; -NODES[1340](VELOCITY_Y,0) = 0.000000; -NODES[1340](VELOCITY_Z,0) = 0.000000; -NODES[1341](VELOCITY_X,0) = 0.000000; -NODES[1341](VELOCITY_Y,0) = 0.000000; -NODES[1341](VELOCITY_Z,0) = 0.000000; -NODES[1342](VELOCITY_X,0) = 0.000000; -NODES[1342](VELOCITY_Y,0) = 0.000000; -NODES[1342](VELOCITY_Z,0) = 0.000000; -NODES[1343](VELOCITY_X,0) = 0.000000; -NODES[1343](VELOCITY_Y,0) = 0.000000; -NODES[1343](VELOCITY_Z,0) = 0.000000; -NODES[1344](VELOCITY_X,0) = 0.000000; -NODES[1344](VELOCITY_Y,0) = 0.000000; -NODES[1344](VELOCITY_Z,0) = 0.000000; -NODES[1345](VELOCITY_X,0) = 0.000000; -NODES[1345](VELOCITY_Y,0) = 0.000000; -NODES[1345](VELOCITY_Z,0) = 0.000000; -NODES[1346](VELOCITY_X,0) = 0.000000; -NODES[1346](VELOCITY_Y,0) = 0.000000; -NODES[1346](VELOCITY_Z,0) = 0.000000; -NODES[1347](VELOCITY_X,0) = 0.000000; -NODES[1347](VELOCITY_Y,0) = 0.000000; -NODES[1347](VELOCITY_Z,0) = 0.000000; -NODES[1348](VELOCITY_X,0) = 0.000000; -NODES[1348](VELOCITY_Y,0) = 0.000000; -NODES[1348](VELOCITY_Z,0) = 0.000000; -NODES[1349](VELOCITY_X,0) = 0.000000; -NODES[1349](VELOCITY_Y,0) = 0.000000; -NODES[1349](VELOCITY_Z,0) = 0.000000; -NODES[1350](VELOCITY_X,0) = 0.000000; -NODES[1350](VELOCITY_Y,0) = 0.000000; -NODES[1350](VELOCITY_Z,0) = 0.000000; -NODES[1351](VELOCITY_X,0) = 0.000000; -NODES[1351](VELOCITY_Y,0) = 0.000000; -NODES[1351](VELOCITY_Z,0) = 0.000000; -NODES[1352](VELOCITY_X,0) = 0.000000; -NODES[1352](VELOCITY_Y,0) = 0.000000; -NODES[1352](VELOCITY_Z,0) = 0.000000; -NODES[1353](VELOCITY_X,0) = 0.000000; -NODES[1353](VELOCITY_Y,0) = 0.000000; -NODES[1353](VELOCITY_Z,0) = 0.000000; -NODES[1354](VELOCITY_X,0) = 0.000000; -NODES[1354](VELOCITY_Y,0) = 0.000000; -NODES[1354](VELOCITY_Z,0) = 0.000000; -NODES[1355](VELOCITY_X,0) = 0.000000; -NODES[1355](VELOCITY_Y,0) = 0.000000; -NODES[1355](VELOCITY_Z,0) = 0.000000; -NODES[1356](VELOCITY_X,0) = 0.000000; -NODES[1356](VELOCITY_Y,0) = 0.000000; -NODES[1356](VELOCITY_Z,0) = 0.000000; -NODES[1357](VELOCITY_X,0) = 0.000000; -NODES[1357](VELOCITY_Y,0) = 0.000000; -NODES[1357](VELOCITY_Z,0) = 0.000000; -NODES[1358](VELOCITY_X,0) = 0.000000; -NODES[1358](VELOCITY_Y,0) = 0.000000; -NODES[1358](VELOCITY_Z,0) = 0.000000; -NODES[1359](VELOCITY_X,0) = 0.000000; -NODES[1359](VELOCITY_Y,0) = 0.000000; -NODES[1359](VELOCITY_Z,0) = 0.000000; -NODES[1360](VELOCITY_X,0) = 0.000000; -NODES[1360](VELOCITY_Y,0) = 0.000000; -NODES[1360](VELOCITY_Z,0) = 0.000000; -NODES[1361](VELOCITY_X,0) = 0.000000; -NODES[1361](VELOCITY_Y,0) = 0.000000; -NODES[1361](VELOCITY_Z,0) = 0.000000; -NODES[1362](VELOCITY_X,0) = 0.000000; -NODES[1362](VELOCITY_Y,0) = 0.000000; -NODES[1362](VELOCITY_Z,0) = 0.000000; -NODES[1363](VELOCITY_X,0) = 0.000000; -NODES[1363](VELOCITY_Y,0) = 0.000000; -NODES[1363](VELOCITY_Z,0) = 0.000000; -NODES[1364](VELOCITY_X,0) = 0.000000; -NODES[1364](VELOCITY_Y,0) = 0.000000; -NODES[1364](VELOCITY_Z,0) = 0.000000; -NODES[1365](VELOCITY_X,0) = 0.000000; -NODES[1365](VELOCITY_Y,0) = 0.000000; -NODES[1365](VELOCITY_Z,0) = 0.000000; -NODES[1366](VELOCITY_X,0) = 0.000000; -NODES[1366](VELOCITY_Y,0) = 0.000000; -NODES[1366](VELOCITY_Z,0) = 0.000000; -NODES[1367](VELOCITY_X,0) = 0.000000; -NODES[1367](VELOCITY_Y,0) = 0.000000; -NODES[1367](VELOCITY_Z,0) = 0.000000; -NODES[1368](VELOCITY_X,0) = 0.000000; -NODES[1368](VELOCITY_Y,0) = 0.000000; -NODES[1368](VELOCITY_Z,0) = 0.000000; -NODES[1369](VELOCITY_X,0) = 0.000000; -NODES[1369](VELOCITY_Y,0) = 0.000000; -NODES[1369](VELOCITY_Z,0) = 0.000000; -NODES[1370](VELOCITY_X,0) = 0.000000; -NODES[1370](VELOCITY_Y,0) = 0.000000; -NODES[1370](VELOCITY_Z,0) = 0.000000; -NODES[1371](VELOCITY_X,0) = 0.000000; -NODES[1371](VELOCITY_Y,0) = 0.000000; -NODES[1371](VELOCITY_Z,0) = 0.000000; -NODES[1372](VELOCITY_X,0) = 0.000000; -NODES[1372](VELOCITY_Y,0) = 0.000000; -NODES[1372](VELOCITY_Z,0) = 0.000000; -NODES[1373](VELOCITY_X,0) = 0.000000; -NODES[1373](VELOCITY_Y,0) = 0.000000; -NODES[1373](VELOCITY_Z,0) = 0.000000; -NODES[1374](VELOCITY_X,0) = 0.000000; -NODES[1374](VELOCITY_Y,0) = 0.000000; -NODES[1374](VELOCITY_Z,0) = 0.000000; -NODES[1375](VELOCITY_X,0) = 0.000000; -NODES[1375](VELOCITY_Y,0) = 0.000000; -NODES[1375](VELOCITY_Z,0) = 0.000000; -NODES[1376](VELOCITY_X,0) = 0.000000; -NODES[1376](VELOCITY_Y,0) = 0.000000; -NODES[1376](VELOCITY_Z,0) = 0.000000; -NODES[1377](VELOCITY_X,0) = 0.000000; -NODES[1377](VELOCITY_Y,0) = 0.000000; -NODES[1377](VELOCITY_Z,0) = 0.000000; -NODES[1378](VELOCITY_X,0) = 0.000000; -NODES[1378](VELOCITY_Y,0) = 0.000000; -NODES[1378](VELOCITY_Z,0) = 0.000000; -NODES[1379](VELOCITY_X,0) = 0.000000; -NODES[1379](VELOCITY_Y,0) = 0.000000; -NODES[1379](VELOCITY_Z,0) = 0.000000; -NODES[1380](VELOCITY_X,0) = 0.000000; -NODES[1380](VELOCITY_Y,0) = 0.000000; -NODES[1380](VELOCITY_Z,0) = 0.000000; -NODES[1381](VELOCITY_X,0) = 0.000000; -NODES[1381](VELOCITY_Y,0) = 0.000000; -NODES[1381](VELOCITY_Z,0) = 0.000000; -NODES[1382](VELOCITY_X,0) = 0.000000; -NODES[1382](VELOCITY_Y,0) = 0.000000; -NODES[1382](VELOCITY_Z,0) = 0.000000; -NODES[1383](VELOCITY_X,0) = 0.000000; -NODES[1383](VELOCITY_Y,0) = 0.000000; -NODES[1383](VELOCITY_Z,0) = 0.000000; -NODES[1384](VELOCITY_X,0) = 0.000000; -NODES[1384](VELOCITY_Y,0) = 0.000000; -NODES[1384](VELOCITY_Z,0) = 0.000000; -NODES[1385](VELOCITY_X,0) = 0.000000; -NODES[1385](VELOCITY_Y,0) = 0.000000; -NODES[1385](VELOCITY_Z,0) = 0.000000; -NODES[1386](VELOCITY_X,0) = 0.000000; -NODES[1386](VELOCITY_Y,0) = 0.000000; -NODES[1386](VELOCITY_Z,0) = 0.000000; -NODES[1387](VELOCITY_X,0) = 0.000000; -NODES[1387](VELOCITY_Y,0) = 0.000000; -NODES[1387](VELOCITY_Z,0) = 0.000000; -NODES[1388](VELOCITY_X,0) = 0.000000; -NODES[1388](VELOCITY_Y,0) = 0.000000; -NODES[1388](VELOCITY_Z,0) = 0.000000; -NODES[1389](VELOCITY_X,0) = 0.000000; -NODES[1389](VELOCITY_Y,0) = 0.000000; -NODES[1389](VELOCITY_Z,0) = 0.000000; -NODES[1390](VELOCITY_X,0) = 0.000000; -NODES[1390](VELOCITY_Y,0) = 0.000000; -NODES[1390](VELOCITY_Z,0) = 0.000000; -NODES[1391](VELOCITY_X,0) = 0.000000; -NODES[1391](VELOCITY_Y,0) = 0.000000; -NODES[1391](VELOCITY_Z,0) = 0.000000; -NODES[1392](VELOCITY_X,0) = 0.000000; -NODES[1392](VELOCITY_Y,0) = 0.000000; -NODES[1392](VELOCITY_Z,0) = 0.000000; -NODES[1393](VELOCITY_X,0) = 0.000000; -NODES[1393](VELOCITY_Y,0) = 0.000000; -NODES[1393](VELOCITY_Z,0) = 0.000000; -NODES[1394](VELOCITY_X,0) = 0.000000; -NODES[1394](VELOCITY_Y,0) = 0.000000; -NODES[1394](VELOCITY_Z,0) = 0.000000; -NODES[1395](VELOCITY_X,0) = 0.000000; -NODES[1395](VELOCITY_Y,0) = 0.000000; -NODES[1395](VELOCITY_Z,0) = 0.000000; -NODES[1396](VELOCITY_X,0) = 0.000000; -NODES[1396](VELOCITY_Y,0) = 0.000000; -NODES[1396](VELOCITY_Z,0) = 0.000000; -NODES[1397](VELOCITY_X,0) = 0.000000; -NODES[1397](VELOCITY_Y,0) = 0.000000; -NODES[1397](VELOCITY_Z,0) = 0.000000; -NODES[1398](VELOCITY_X,0) = 0.000000; -NODES[1398](VELOCITY_Y,0) = 0.000000; -NODES[1398](VELOCITY_Z,0) = 0.000000; -NODES[1399](VELOCITY_X,0) = 0.000000; -NODES[1399](VELOCITY_Y,0) = 0.000000; -NODES[1399](VELOCITY_Z,0) = 0.000000; -NODES[1400](VELOCITY_X,0) = 0.000000; -NODES[1400](VELOCITY_Y,0) = 0.000000; -NODES[1400](VELOCITY_Z,0) = 0.000000; -NODES[1401](VELOCITY_X,0) = 0.000000; -NODES[1401](VELOCITY_Y,0) = 0.000000; -NODES[1401](VELOCITY_Z,0) = 0.000000; -NODES[1402](VELOCITY_X,0) = 0.000000; -NODES[1402](VELOCITY_Y,0) = 0.000000; -NODES[1402](VELOCITY_Z,0) = 0.000000; -NODES[1403](VELOCITY_X,0) = 0.000000; -NODES[1403](VELOCITY_Y,0) = 0.000000; -NODES[1403](VELOCITY_Z,0) = 0.000000; -NODES[1404](VELOCITY_X,0) = 0.000000; -NODES[1404](VELOCITY_Y,0) = 0.000000; -NODES[1404](VELOCITY_Z,0) = 0.000000; -NODES[1405](VELOCITY_X,0) = 0.000000; -NODES[1405](VELOCITY_Y,0) = 0.000000; -NODES[1405](VELOCITY_Z,0) = 0.000000; -NODES[1406](VELOCITY_X,0) = 0.000000; -NODES[1406](VELOCITY_Y,0) = 0.000000; -NODES[1406](VELOCITY_Z,0) = 0.000000; -NODES[1407](VELOCITY_X,0) = 0.000000; -NODES[1407](VELOCITY_Y,0) = 0.000000; -NODES[1407](VELOCITY_Z,0) = 0.000000; -NODES[1408](VELOCITY_X,0) = 0.000000; -NODES[1408](VELOCITY_Y,0) = 0.000000; -NODES[1408](VELOCITY_Z,0) = 0.000000; -NODES[1409](VELOCITY_X,0) = 0.000000; -NODES[1409](VELOCITY_Y,0) = 0.000000; -NODES[1409](VELOCITY_Z,0) = 0.000000; -NODES[1410](VELOCITY_X,0) = 0.000000; -NODES[1410](VELOCITY_Y,0) = 0.000000; -NODES[1410](VELOCITY_Z,0) = 0.000000; -NODES[1411](VELOCITY_X,0) = 0.000000; -NODES[1411](VELOCITY_Y,0) = 0.000000; -NODES[1411](VELOCITY_Z,0) = 0.000000; -NODES[1412](VELOCITY_X,0) = 0.000000; -NODES[1412](VELOCITY_Y,0) = 0.000000; -NODES[1412](VELOCITY_Z,0) = 0.000000; -NODES[1413](VELOCITY_X,0) = 0.000000; -NODES[1413](VELOCITY_Y,0) = 0.000000; -NODES[1413](VELOCITY_Z,0) = 0.000000; -NODES[1414](VELOCITY_X,0) = 0.000000; -NODES[1414](VELOCITY_Y,0) = 0.000000; -NODES[1414](VELOCITY_Z,0) = 0.000000; -NODES[1415](VELOCITY_X,0) = 0.000000; -NODES[1415](VELOCITY_Y,0) = 0.000000; -NODES[1415](VELOCITY_Z,0) = 0.000000; -NODES[1416](VELOCITY_X,0) = 0.000000; -NODES[1416](VELOCITY_Y,0) = 0.000000; -NODES[1416](VELOCITY_Z,0) = 0.000000; -NODES[1417](VELOCITY_X,0) = 0.000000; -NODES[1417](VELOCITY_Y,0) = 0.000000; -NODES[1417](VELOCITY_Z,0) = 0.000000; -NODES[1418](VELOCITY_X,0) = 0.000000; -NODES[1418](VELOCITY_Y,0) = 0.000000; -NODES[1418](VELOCITY_Z,0) = 0.000000; -NODES[1419](VELOCITY_X,0) = 0.000000; -NODES[1419](VELOCITY_Y,0) = 0.000000; -NODES[1419](VELOCITY_Z,0) = 0.000000; -NODES[1420](VELOCITY_X,0) = 0.000000; -NODES[1420](VELOCITY_Y,0) = 0.000000; -NODES[1420](VELOCITY_Z,0) = 0.000000; -NODES[1421](VELOCITY_X,0) = 0.000000; -NODES[1421](VELOCITY_Y,0) = 0.000000; -NODES[1421](VELOCITY_Z,0) = 0.000000; -NODES[1422](VELOCITY_X,0) = 0.000000; -NODES[1422](VELOCITY_Y,0) = 0.000000; -NODES[1422](VELOCITY_Z,0) = 0.000000; -NODES[1423](VELOCITY_X,0) = 0.000000; -NODES[1423](VELOCITY_Y,0) = 0.000000; -NODES[1423](VELOCITY_Z,0) = 0.000000; -NODES[1424](VELOCITY_X,0) = 0.000000; -NODES[1424](VELOCITY_Y,0) = 0.000000; -NODES[1424](VELOCITY_Z,0) = 0.000000; -NODES[1425](VELOCITY_X,0) = 0.000000; -NODES[1425](VELOCITY_Y,0) = 0.000000; -NODES[1425](VELOCITY_Z,0) = 0.000000; -NODES[1426](VELOCITY_X,0) = 0.000000; -NODES[1426](VELOCITY_Y,0) = 0.000000; -NODES[1426](VELOCITY_Z,0) = 0.000000; -NODES[1427](VELOCITY_X,0) = 0.000000; -NODES[1427](VELOCITY_Y,0) = 0.000000; -NODES[1427](VELOCITY_Z,0) = 0.000000; -NODES[1428](VELOCITY_X,0) = 0.000000; -NODES[1428](VELOCITY_Y,0) = 0.000000; -NODES[1428](VELOCITY_Z,0) = 0.000000; -NODES[1429](VELOCITY_X,0) = 0.000000; -NODES[1429](VELOCITY_Y,0) = 0.000000; -NODES[1429](VELOCITY_Z,0) = 0.000000; -NODES[1430](VELOCITY_X,0) = 0.000000; -NODES[1430](VELOCITY_Y,0) = 0.000000; -NODES[1430](VELOCITY_Z,0) = 0.000000; -NODES[1431](VELOCITY_X,0) = 0.000000; -NODES[1431](VELOCITY_Y,0) = 0.000000; -NODES[1431](VELOCITY_Z,0) = 0.000000; -NODES[1432](VELOCITY_X,0) = 0.000000; -NODES[1432](VELOCITY_Y,0) = 0.000000; -NODES[1432](VELOCITY_Z,0) = 0.000000; -NODES[1433](VELOCITY_X,0) = 0.000000; -NODES[1433](VELOCITY_Y,0) = 0.000000; -NODES[1433](VELOCITY_Z,0) = 0.000000; -NODES[1434](VELOCITY_X,0) = 0.000000; -NODES[1434](VELOCITY_Y,0) = 0.000000; -NODES[1434](VELOCITY_Z,0) = 0.000000; -NODES[1435](VELOCITY_X,0) = 0.000000; -NODES[1435](VELOCITY_Y,0) = 0.000000; -NODES[1435](VELOCITY_Z,0) = 0.000000; -NODES[1436](VELOCITY_X,0) = 0.000000; -NODES[1436](VELOCITY_Y,0) = 0.000000; -NODES[1436](VELOCITY_Z,0) = 0.000000; -NODES[1437](VELOCITY_X,0) = 0.000000; -NODES[1437](VELOCITY_Y,0) = 0.000000; -NODES[1437](VELOCITY_Z,0) = 0.000000; -NODES[1438](VELOCITY_X,0) = 0.000000; -NODES[1438](VELOCITY_Y,0) = 0.000000; -NODES[1438](VELOCITY_Z,0) = 0.000000; -NODES[1439](VELOCITY_X,0) = 0.000000; -NODES[1439](VELOCITY_Y,0) = 0.000000; -NODES[1439](VELOCITY_Z,0) = 0.000000; -NODES[1440](VELOCITY_X,0) = 0.000000; -NODES[1440](VELOCITY_Y,0) = 0.000000; -NODES[1440](VELOCITY_Z,0) = 0.000000; -NODES[1441](VELOCITY_X,0) = 0.000000; -NODES[1441](VELOCITY_Y,0) = 0.000000; -NODES[1441](VELOCITY_Z,0) = 0.000000; -NODES[1442](VELOCITY_X,0) = 0.000000; -NODES[1442](VELOCITY_Y,0) = 0.000000; -NODES[1442](VELOCITY_Z,0) = 0.000000; -NODES[1443](VELOCITY_X,0) = 0.000000; -NODES[1443](VELOCITY_Y,0) = 0.000000; -NODES[1443](VELOCITY_Z,0) = 0.000000; -NODES[1444](VELOCITY_X,0) = 0.000000; -NODES[1444](VELOCITY_Y,0) = 0.000000; -NODES[1444](VELOCITY_Z,0) = 0.000000; -NODES[1445](VELOCITY_X,0) = 0.000000; -NODES[1445](VELOCITY_Y,0) = 0.000000; -NODES[1445](VELOCITY_Z,0) = 0.000000; -NODES[1446](VELOCITY_X,0) = 0.000000; -NODES[1446](VELOCITY_Y,0) = 0.000000; -NODES[1446](VELOCITY_Z,0) = 0.000000; -NODES[1447](VELOCITY_X,0) = 0.000000; -NODES[1447](VELOCITY_Y,0) = 0.000000; -NODES[1447](VELOCITY_Z,0) = 0.000000; -NODES[1448](VELOCITY_X,0) = 0.000000; -NODES[1448](VELOCITY_Y,0) = 0.000000; -NODES[1448](VELOCITY_Z,0) = 0.000000; -NODES[1449](VELOCITY_X,0) = 0.000000; -NODES[1449](VELOCITY_Y,0) = 0.000000; -NODES[1449](VELOCITY_Z,0) = 0.000000; -NODES[1450](VELOCITY_X,0) = 0.000000; -NODES[1450](VELOCITY_Y,0) = 0.000000; -NODES[1450](VELOCITY_Z,0) = 0.000000; -NODES[1451](VELOCITY_X,0) = 0.000000; -NODES[1451](VELOCITY_Y,0) = 0.000000; -NODES[1451](VELOCITY_Z,0) = 0.000000; -NODES[1452](VELOCITY_X,0) = 0.000000; -NODES[1452](VELOCITY_Y,0) = 0.000000; -NODES[1452](VELOCITY_Z,0) = 0.000000; -NODES[1453](VELOCITY_X,0) = 0.000000; -NODES[1453](VELOCITY_Y,0) = 0.000000; -NODES[1453](VELOCITY_Z,0) = 0.000000; -NODES[1454](VELOCITY_X,0) = 0.000000; -NODES[1454](VELOCITY_Y,0) = 0.000000; -NODES[1454](VELOCITY_Z,0) = 0.000000; -NODES[1455](VELOCITY_X,0) = 0.000000; -NODES[1455](VELOCITY_Y,0) = 0.000000; -NODES[1455](VELOCITY_Z,0) = 0.000000; -NODES[1456](VELOCITY_X,0) = 0.000000; -NODES[1456](VELOCITY_Y,0) = 0.000000; -NODES[1456](VELOCITY_Z,0) = 0.000000; -NODES[1457](VELOCITY_X,0) = 0.000000; -NODES[1457](VELOCITY_Y,0) = 0.000000; -NODES[1457](VELOCITY_Z,0) = 0.000000; -NODES[1458](VELOCITY_X,0) = 0.000000; -NODES[1458](VELOCITY_Y,0) = 0.000000; -NODES[1458](VELOCITY_Z,0) = 0.000000; -NODES[1459](VELOCITY_X,0) = 0.000000; -NODES[1459](VELOCITY_Y,0) = 0.000000; -NODES[1459](VELOCITY_Z,0) = 0.000000; -NODES[1460](VELOCITY_X,0) = 0.000000; -NODES[1460](VELOCITY_Y,0) = 0.000000; -NODES[1460](VELOCITY_Z,0) = 0.000000; -NODES[1461](VELOCITY_X,0) = 0.000000; -NODES[1461](VELOCITY_Y,0) = 0.000000; -NODES[1461](VELOCITY_Z,0) = 0.000000; -NODES[1462](VELOCITY_X,0) = 0.000000; -NODES[1462](VELOCITY_Y,0) = 0.000000; -NODES[1462](VELOCITY_Z,0) = 0.000000; -NODES[1463](VELOCITY_X,0) = 0.000000; -NODES[1463](VELOCITY_Y,0) = 0.000000; -NODES[1463](VELOCITY_Z,0) = 0.000000; -NODES[1464](VELOCITY_X,0) = 0.000000; -NODES[1464](VELOCITY_Y,0) = 0.000000; -NODES[1464](VELOCITY_Z,0) = 0.000000; -NODES[1465](VELOCITY_X,0) = 0.000000; -NODES[1465](VELOCITY_Y,0) = 0.000000; -NODES[1465](VELOCITY_Z,0) = 0.000000; -NODES[1466](VELOCITY_X,0) = 0.000000; -NODES[1466](VELOCITY_Y,0) = 0.000000; -NODES[1466](VELOCITY_Z,0) = 0.000000; -NODES[1467](VELOCITY_X,0) = 0.000000; -NODES[1467](VELOCITY_Y,0) = 0.000000; -NODES[1467](VELOCITY_Z,0) = 0.000000; -NODES[1468](VELOCITY_X,0) = 0.000000; -NODES[1468](VELOCITY_Y,0) = 0.000000; -NODES[1468](VELOCITY_Z,0) = 0.000000; -NODES[1469](VELOCITY_X,0) = 0.000000; -NODES[1469](VELOCITY_Y,0) = 0.000000; -NODES[1469](VELOCITY_Z,0) = 0.000000; -NODES[1470](VELOCITY_X,0) = 0.000000; -NODES[1470](VELOCITY_Y,0) = 0.000000; -NODES[1470](VELOCITY_Z,0) = 0.000000; -NODES[1471](VELOCITY_X,0) = 0.000000; -NODES[1471](VELOCITY_Y,0) = 0.000000; -NODES[1471](VELOCITY_Z,0) = 0.000000; -NODES[1472](VELOCITY_X,0) = 0.000000; -NODES[1472](VELOCITY_Y,0) = 0.000000; -NODES[1472](VELOCITY_Z,0) = 0.000000; -NODES[1473](VELOCITY_X,0) = 0.000000; -NODES[1473](VELOCITY_Y,0) = 0.000000; -NODES[1473](VELOCITY_Z,0) = 0.000000; -NODES[1474](VELOCITY_X,0) = 0.000000; -NODES[1474](VELOCITY_Y,0) = 0.000000; -NODES[1474](VELOCITY_Z,0) = 0.000000; -NODES[1475](VELOCITY_X,0) = 0.000000; -NODES[1475](VELOCITY_Y,0) = 0.000000; -NODES[1475](VELOCITY_Z,0) = 0.000000; -NODES[1476](VELOCITY_X,0) = 0.000000; -NODES[1476](VELOCITY_Y,0) = 0.000000; -NODES[1476](VELOCITY_Z,0) = 0.000000; -NODES[1477](VELOCITY_X,0) = 0.000000; -NODES[1477](VELOCITY_Y,0) = 0.000000; -NODES[1477](VELOCITY_Z,0) = 0.000000; -NODES[1478](VELOCITY_X,0) = 0.000000; -NODES[1478](VELOCITY_Y,0) = 0.000000; -NODES[1478](VELOCITY_Z,0) = 0.000000; -NODES[1479](VELOCITY_X,0) = 0.000000; -NODES[1479](VELOCITY_Y,0) = 0.000000; -NODES[1479](VELOCITY_Z,0) = 0.000000; -NODES[1480](VELOCITY_X,0) = 0.000000; -NODES[1480](VELOCITY_Y,0) = 0.000000; -NODES[1480](VELOCITY_Z,0) = 0.000000; -NODES[1481](VELOCITY_X,0) = 0.000000; -NODES[1481](VELOCITY_Y,0) = 0.000000; -NODES[1481](VELOCITY_Z,0) = 0.000000; -NODES[1482](VELOCITY_X,0) = 0.000000; -NODES[1482](VELOCITY_Y,0) = 0.000000; -NODES[1482](VELOCITY_Z,0) = 0.000000; -NODES[1483](VELOCITY_X,0) = 0.000000; -NODES[1483](VELOCITY_Y,0) = 0.000000; -NODES[1483](VELOCITY_Z,0) = 0.000000; -NODES[1484](VELOCITY_X,0) = 0.000000; -NODES[1484](VELOCITY_Y,0) = 0.000000; -NODES[1484](VELOCITY_Z,0) = 0.000000; -NODES[1485](VELOCITY_X,0) = 0.000000; -NODES[1485](VELOCITY_Y,0) = 0.000000; -NODES[1485](VELOCITY_Z,0) = 0.000000; -NODES[1486](VELOCITY_X,0) = 0.000000; -NODES[1486](VELOCITY_Y,0) = 0.000000; -NODES[1486](VELOCITY_Z,0) = 0.000000; -NODES[1487](VELOCITY_X,0) = 0.000000; -NODES[1487](VELOCITY_Y,0) = 0.000000; -NODES[1487](VELOCITY_Z,0) = 0.000000; -NODES[1488](VELOCITY_X,0) = 0.000000; -NODES[1488](VELOCITY_Y,0) = 0.000000; -NODES[1488](VELOCITY_Z,0) = 0.000000; -NODES[1489](VELOCITY_X,0) = 0.000000; -NODES[1489](VELOCITY_Y,0) = 0.000000; -NODES[1489](VELOCITY_Z,0) = 0.000000; -NODES[1490](VELOCITY_X,0) = 0.000000; -NODES[1490](VELOCITY_Y,0) = 0.000000; -NODES[1490](VELOCITY_Z,0) = 0.000000; -NODES[1491](VELOCITY_X,0) = 0.000000; -NODES[1491](VELOCITY_Y,0) = 0.000000; -NODES[1491](VELOCITY_Z,0) = 0.000000; -NODES[1492](VELOCITY_X,0) = 0.000000; -NODES[1492](VELOCITY_Y,0) = 0.000000; -NODES[1492](VELOCITY_Z,0) = 0.000000; -NODES[1493](VELOCITY_X,0) = 0.000000; -NODES[1493](VELOCITY_Y,0) = 0.000000; -NODES[1493](VELOCITY_Z,0) = 0.000000; -NODES[1494](VELOCITY_X,0) = 0.000000; -NODES[1494](VELOCITY_Y,0) = 0.000000; -NODES[1494](VELOCITY_Z,0) = 0.000000; -NODES[1495](VELOCITY_X,0) = 0.000000; -NODES[1495](VELOCITY_Y,0) = 0.000000; -NODES[1495](VELOCITY_Z,0) = 0.000000; -NODES[1496](VELOCITY_X,0) = 0.000000; -NODES[1496](VELOCITY_Y,0) = 0.000000; -NODES[1496](VELOCITY_Z,0) = 0.000000; -NODES[1497](VELOCITY_X,0) = 0.000000; -NODES[1497](VELOCITY_Y,0) = 0.000000; -NODES[1497](VELOCITY_Z,0) = 0.000000; -NODES[1498](VELOCITY_X,0) = 0.000000; -NODES[1498](VELOCITY_Y,0) = 0.000000; -NODES[1498](VELOCITY_Z,0) = 0.000000; -NODES[1499](VELOCITY_X,0) = 0.000000; -NODES[1499](VELOCITY_Y,0) = 0.000000; -NODES[1499](VELOCITY_Z,0) = 0.000000; -NODES[1500](VELOCITY_X,0) = 0.000000; -NODES[1500](VELOCITY_Y,0) = 0.000000; -NODES[1500](VELOCITY_Z,0) = 0.000000; -NODES[1501](VELOCITY_X,0) = 0.000000; -NODES[1501](VELOCITY_Y,0) = 0.000000; -NODES[1501](VELOCITY_Z,0) = 0.000000; -NODES[1502](VELOCITY_X,0) = 0.000000; -NODES[1502](VELOCITY_Y,0) = 0.000000; -NODES[1502](VELOCITY_Z,0) = 0.000000; -NODES[1503](VELOCITY_X,0) = 0.000000; -NODES[1503](VELOCITY_Y,0) = 0.000000; -NODES[1503](VELOCITY_Z,0) = 0.000000; -NODES[1504](VELOCITY_X,0) = 0.000000; -NODES[1504](VELOCITY_Y,0) = 0.000000; -NODES[1504](VELOCITY_Z,0) = 0.000000; -NODES[1505](VELOCITY_X,0) = 0.000000; -NODES[1505](VELOCITY_Y,0) = 0.000000; -NODES[1505](VELOCITY_Z,0) = 0.000000; -NODES[1506](VELOCITY_X,0) = 0.000000; -NODES[1506](VELOCITY_Y,0) = 0.000000; -NODES[1506](VELOCITY_Z,0) = 0.000000; -NODES[1507](VELOCITY_X,0) = 0.000000; -NODES[1507](VELOCITY_Y,0) = 0.000000; -NODES[1507](VELOCITY_Z,0) = 0.000000; -NODES[1508](VELOCITY_X,0) = 0.000000; -NODES[1508](VELOCITY_Y,0) = 0.000000; -NODES[1508](VELOCITY_Z,0) = 0.000000; -NODES[1509](VELOCITY_X,0) = 0.000000; -NODES[1509](VELOCITY_Y,0) = 0.000000; -NODES[1509](VELOCITY_Z,0) = 0.000000; -NODES[1510](VELOCITY_X,0) = 0.000000; -NODES[1510](VELOCITY_Y,0) = 0.000000; -NODES[1510](VELOCITY_Z,0) = 0.000000; -NODES[1511](VELOCITY_X,0) = 0.000000; -NODES[1511](VELOCITY_Y,0) = 0.000000; -NODES[1511](VELOCITY_Z,0) = 0.000000; -NODES[1512](VELOCITY_X,0) = 0.000000; -NODES[1512](VELOCITY_Y,0) = 0.000000; -NODES[1512](VELOCITY_Z,0) = 0.000000; -NODES[1513](VELOCITY_X,0) = 0.000000; -NODES[1513](VELOCITY_Y,0) = 0.000000; -NODES[1513](VELOCITY_Z,0) = 0.000000; -NODES[1514](VELOCITY_X,0) = 0.000000; -NODES[1514](VELOCITY_Y,0) = 0.000000; -NODES[1514](VELOCITY_Z,0) = 0.000000; -NODES[1515](VELOCITY_X,0) = 0.000000; -NODES[1515](VELOCITY_Y,0) = 0.000000; -NODES[1515](VELOCITY_Z,0) = 0.000000; -NODES[1516](VELOCITY_X,0) = 0.000000; -NODES[1516](VELOCITY_Y,0) = 0.000000; -NODES[1516](VELOCITY_Z,0) = 0.000000; -NODES[1517](VELOCITY_X,0) = 0.000000; -NODES[1517](VELOCITY_Y,0) = 0.000000; -NODES[1517](VELOCITY_Z,0) = 0.000000; -NODES[1518](VELOCITY_X,0) = 0.000000; -NODES[1518](VELOCITY_Y,0) = 0.000000; -NODES[1518](VELOCITY_Z,0) = 0.000000; -NODES[1519](VELOCITY_X,0) = 0.000000; -NODES[1519](VELOCITY_Y,0) = 0.000000; -NODES[1519](VELOCITY_Z,0) = 0.000000; -NODES[1520](VELOCITY_X,0) = 0.000000; -NODES[1520](VELOCITY_Y,0) = 0.000000; -NODES[1520](VELOCITY_Z,0) = 0.000000; -NODES[1521](VELOCITY_X,0) = 0.000000; -NODES[1521](VELOCITY_Y,0) = 0.000000; -NODES[1521](VELOCITY_Z,0) = 0.000000; -NODES[1522](VELOCITY_X,0) = 0.000000; -NODES[1522](VELOCITY_Y,0) = 0.000000; -NODES[1522](VELOCITY_Z,0) = 0.000000; -NODES[1523](VELOCITY_X,0) = 0.000000; -NODES[1523](VELOCITY_Y,0) = 0.000000; -NODES[1523](VELOCITY_Z,0) = 0.000000; -NODES[1524](VELOCITY_X,0) = 0.000000; -NODES[1524](VELOCITY_Y,0) = 0.000000; -NODES[1524](VELOCITY_Z,0) = 0.000000; -NODES[1525](VELOCITY_X,0) = 0.000000; -NODES[1525](VELOCITY_Y,0) = 0.000000; -NODES[1525](VELOCITY_Z,0) = 0.000000; -NODES[1526](VELOCITY_X,0) = 0.000000; -NODES[1526](VELOCITY_Y,0) = 0.000000; -NODES[1526](VELOCITY_Z,0) = 0.000000; -NODES[1527](VELOCITY_X,0) = 0.000000; -NODES[1527](VELOCITY_Y,0) = 0.000000; -NODES[1527](VELOCITY_Z,0) = 0.000000; -NODES[1528](VELOCITY_X,0) = 0.000000; -NODES[1528](VELOCITY_Y,0) = 0.000000; -NODES[1528](VELOCITY_Z,0) = 0.000000; -NODES[1529](VELOCITY_X,0) = 0.000000; -NODES[1529](VELOCITY_Y,0) = 0.000000; -NODES[1529](VELOCITY_Z,0) = 0.000000; -NODES[1530](VELOCITY_X,0) = 0.000000; -NODES[1530](VELOCITY_Y,0) = 0.000000; -NODES[1530](VELOCITY_Z,0) = 0.000000; -NODES[1531](VELOCITY_X,0) = 0.000000; -NODES[1531](VELOCITY_Y,0) = 0.000000; -NODES[1531](VELOCITY_Z,0) = 0.000000; -NODES[1532](VELOCITY_X,0) = 0.000000; -NODES[1532](VELOCITY_Y,0) = 0.000000; -NODES[1532](VELOCITY_Z,0) = 0.000000; -NODES[1533](VELOCITY_X,0) = 0.000000; -NODES[1533](VELOCITY_Y,0) = 0.000000; -NODES[1533](VELOCITY_Z,0) = 0.000000; -NODES[1534](VELOCITY_X,0) = 0.000000; -NODES[1534](VELOCITY_Y,0) = 0.000000; -NODES[1534](VELOCITY_Z,0) = 0.000000; -NODES[1535](VELOCITY_X,0) = 0.000000; -NODES[1535](VELOCITY_Y,0) = 0.000000; -NODES[1535](VELOCITY_Z,0) = 0.000000; -NODES[1536](VELOCITY_X,0) = 0.000000; -NODES[1536](VELOCITY_Y,0) = 0.000000; -NODES[1536](VELOCITY_Z,0) = 0.000000; -NODES[1537](VELOCITY_X,0) = 0.000000; -NODES[1537](VELOCITY_Y,0) = 0.000000; -NODES[1537](VELOCITY_Z,0) = 0.000000; -NODES[1538](VELOCITY_X,0) = 0.000000; -NODES[1538](VELOCITY_Y,0) = 0.000000; -NODES[1538](VELOCITY_Z,0) = 0.000000; -NODES[1539](VELOCITY_X,0) = 0.000000; -NODES[1539](VELOCITY_Y,0) = 0.000000; -NODES[1539](VELOCITY_Z,0) = 0.000000; -NODES[1540](VELOCITY_X,0) = 0.000000; -NODES[1540](VELOCITY_Y,0) = 0.000000; -NODES[1540](VELOCITY_Z,0) = 0.000000; -NODES[1541](VELOCITY_X,0) = 0.000000; -NODES[1541](VELOCITY_Y,0) = 0.000000; -NODES[1541](VELOCITY_Z,0) = 0.000000; -NODES[1542](VELOCITY_X,0) = 0.000000; -NODES[1542](VELOCITY_Y,0) = 0.000000; -NODES[1542](VELOCITY_Z,0) = 0.000000; -NODES[1544](VELOCITY_X,0) = 0.000000; -NODES[1544](VELOCITY_Y,0) = 0.000000; -NODES[1544](VELOCITY_Z,0) = 0.000000; -NODES[1545](VELOCITY_X,0) = 0.000000; -NODES[1545](VELOCITY_Y,0) = 0.000000; -NODES[1545](VELOCITY_Z,0) = 0.000000; -NODES[1547](VELOCITY_X,0) = 0.000000; -NODES[1547](VELOCITY_Y,0) = 0.000000; -NODES[1547](VELOCITY_Z,0) = 0.000000; -NODES[1548](VELOCITY_X,0) = 0.000000; -NODES[1548](VELOCITY_Y,0) = 0.000000; -NODES[1548](VELOCITY_Z,0) = 0.000000; -NODES[1549](VELOCITY_X,0) = 0.000000; -NODES[1549](VELOCITY_Y,0) = 0.000000; -NODES[1549](VELOCITY_Z,0) = 0.000000; -NODES[1550](VELOCITY_X,0) = 0.000000; -NODES[1550](VELOCITY_Y,0) = 0.000000; -NODES[1550](VELOCITY_Z,0) = 0.000000; -NODES[1551](VELOCITY_X,0) = 0.000000; -NODES[1551](VELOCITY_Y,0) = 0.000000; -NODES[1551](VELOCITY_Z,0) = 0.000000; -NODES[1552](VELOCITY_X,0) = 0.000000; -NODES[1552](VELOCITY_Y,0) = 0.000000; -NODES[1552](VELOCITY_Z,0) = 0.000000; -NODES[1554](VELOCITY_X,0) = 0.000000; -NODES[1554](VELOCITY_Y,0) = 0.000000; -NODES[1554](VELOCITY_Z,0) = 0.000000; -NODES[1555](VELOCITY_X,0) = 0.000000; -NODES[1555](VELOCITY_Y,0) = 0.000000; -NODES[1555](VELOCITY_Z,0) = 0.000000; -NODES[1556](VELOCITY_X,0) = 0.000000; -NODES[1556](VELOCITY_Y,0) = 0.000000; -NODES[1556](VELOCITY_Z,0) = 0.000000; -NODES[1557](VELOCITY_X,0) = 0.000000; -NODES[1557](VELOCITY_Y,0) = 0.000000; -NODES[1557](VELOCITY_Z,0) = 0.000000; -NODES[1558](VELOCITY_X,0) = 0.000000; -NODES[1558](VELOCITY_Y,0) = 0.000000; -NODES[1558](VELOCITY_Z,0) = 0.000000; -NODES[1559](VELOCITY_X,0) = 0.000000; -NODES[1559](VELOCITY_Y,0) = 0.000000; -NODES[1559](VELOCITY_Z,0) = 0.000000; -NODES[1560](VELOCITY_X,0) = 0.000000; -NODES[1560](VELOCITY_Y,0) = 0.000000; -NODES[1560](VELOCITY_Z,0) = 0.000000; -NODES[1561](VELOCITY_X,0) = 0.000000; -NODES[1561](VELOCITY_Y,0) = 0.000000; -NODES[1561](VELOCITY_Z,0) = 0.000000; -NODES[1562](VELOCITY_X,0) = 0.000000; -NODES[1562](VELOCITY_Y,0) = 0.000000; -NODES[1562](VELOCITY_Z,0) = 0.000000; -NODES[1564](VELOCITY_X,0) = 0.000000; -NODES[1564](VELOCITY_Y,0) = 0.000000; -NODES[1564](VELOCITY_Z,0) = 0.000000; -NODES[1565](VELOCITY_X,0) = 0.000000; -NODES[1565](VELOCITY_Y,0) = 0.000000; -NODES[1565](VELOCITY_Z,0) = 0.000000; -NODES[1566](VELOCITY_X,0) = 0.000000; -NODES[1566](VELOCITY_Y,0) = 0.000000; -NODES[1566](VELOCITY_Z,0) = 0.000000; -NODES[1567](VELOCITY_X,0) = 0.000000; -NODES[1567](VELOCITY_Y,0) = 0.000000; -NODES[1567](VELOCITY_Z,0) = 0.000000; -NODES[1568](VELOCITY_X,0) = 0.000000; -NODES[1568](VELOCITY_Y,0) = 0.000000; -NODES[1568](VELOCITY_Z,0) = 0.000000; -NODES[1569](VELOCITY_X,0) = 0.000000; -NODES[1569](VELOCITY_Y,0) = 0.000000; -NODES[1569](VELOCITY_Z,0) = 0.000000; -NODES[1570](VELOCITY_X,0) = 0.000000; -NODES[1570](VELOCITY_Y,0) = 0.000000; -NODES[1570](VELOCITY_Z,0) = 0.000000; -NODES[1571](VELOCITY_X,0) = 0.000000; -NODES[1571](VELOCITY_Y,0) = 0.000000; -NODES[1571](VELOCITY_Z,0) = 0.000000; -NODES[1572](VELOCITY_X,0) = 0.000000; -NODES[1572](VELOCITY_Y,0) = 0.000000; -NODES[1572](VELOCITY_Z,0) = 0.000000; -NODES[1573](VELOCITY_X,0) = 0.000000; -NODES[1573](VELOCITY_Y,0) = 0.000000; -NODES[1573](VELOCITY_Z,0) = 0.000000; -NODES[1574](VELOCITY_X,0) = 0.000000; -NODES[1574](VELOCITY_Y,0) = 0.000000; -NODES[1574](VELOCITY_Z,0) = 0.000000; -NODES[1576](VELOCITY_X,0) = 0.000000; -NODES[1576](VELOCITY_Y,0) = 0.000000; -NODES[1576](VELOCITY_Z,0) = 0.000000; -NODES[1577](VELOCITY_X,0) = 0.000000; -NODES[1577](VELOCITY_Y,0) = 0.000000; -NODES[1577](VELOCITY_Z,0) = 0.000000; -NODES[1578](VELOCITY_X,0) = 0.000000; -NODES[1578](VELOCITY_Y,0) = 0.000000; -NODES[1578](VELOCITY_Z,0) = 0.000000; -NODES[1579](VELOCITY_X,0) = 0.000000; -NODES[1579](VELOCITY_Y,0) = 0.000000; -NODES[1579](VELOCITY_Z,0) = 0.000000; -NODES[1580](VELOCITY_X,0) = 0.000000; -NODES[1580](VELOCITY_Y,0) = 0.000000; -NODES[1580](VELOCITY_Z,0) = 0.000000; -NODES[1581](VELOCITY_X,0) = 0.000000; -NODES[1581](VELOCITY_Y,0) = 0.000000; -NODES[1581](VELOCITY_Z,0) = 0.000000; -NODES[1582](VELOCITY_X,0) = 0.000000; -NODES[1582](VELOCITY_Y,0) = 0.000000; -NODES[1582](VELOCITY_Z,0) = 0.000000; -NODES[1583](VELOCITY_X,0) = 0.000000; -NODES[1583](VELOCITY_Y,0) = 0.000000; -NODES[1583](VELOCITY_Z,0) = 0.000000; -NODES[1584](VELOCITY_X,0) = 0.000000; -NODES[1584](VELOCITY_Y,0) = 0.000000; -NODES[1584](VELOCITY_Z,0) = 0.000000; -NODES[1585](VELOCITY_X,0) = 0.000000; -NODES[1585](VELOCITY_Y,0) = 0.000000; -NODES[1585](VELOCITY_Z,0) = 0.000000; -NODES[1586](VELOCITY_X,0) = 0.000000; -NODES[1586](VELOCITY_Y,0) = 0.000000; -NODES[1586](VELOCITY_Z,0) = 0.000000; -NODES[1587](VELOCITY_X,0) = 0.000000; -NODES[1587](VELOCITY_Y,0) = 0.000000; -NODES[1587](VELOCITY_Z,0) = 0.000000; -NODES[1588](VELOCITY_X,0) = 0.000000; -NODES[1588](VELOCITY_Y,0) = 0.000000; -NODES[1588](VELOCITY_Z,0) = 0.000000; -NODES[1589](VELOCITY_X,0) = 0.000000; -NODES[1589](VELOCITY_Y,0) = 0.000000; -NODES[1589](VELOCITY_Z,0) = 0.000000; -NODES[1590](VELOCITY_X,0) = 0.000000; -NODES[1590](VELOCITY_Y,0) = 0.000000; -NODES[1590](VELOCITY_Z,0) = 0.000000; -NODES[1591](VELOCITY_X,0) = 0.000000; -NODES[1591](VELOCITY_Y,0) = 0.000000; -NODES[1591](VELOCITY_Z,0) = 0.000000; -NODES[1592](VELOCITY_X,0) = 0.000000; -NODES[1592](VELOCITY_Y,0) = 0.000000; -NODES[1592](VELOCITY_Z,0) = 0.000000; -NODES[1594](VELOCITY_X,0) = 0.000000; -NODES[1594](VELOCITY_Y,0) = 0.000000; -NODES[1594](VELOCITY_Z,0) = 0.000000; -NODES[1595](VELOCITY_X,0) = 0.000000; -NODES[1595](VELOCITY_Y,0) = 0.000000; -NODES[1595](VELOCITY_Z,0) = 0.000000; -NODES[1596](VELOCITY_X,0) = 0.000000; -NODES[1596](VELOCITY_Y,0) = 0.000000; -NODES[1596](VELOCITY_Z,0) = 0.000000; -NODES[1597](VELOCITY_X,0) = 0.000000; -NODES[1597](VELOCITY_Y,0) = 0.000000; -NODES[1597](VELOCITY_Z,0) = 0.000000; -NODES[1598](VELOCITY_X,0) = 0.000000; -NODES[1598](VELOCITY_Y,0) = 0.000000; -NODES[1598](VELOCITY_Z,0) = 0.000000; -NODES[1599](VELOCITY_X,0) = 0.000000; -NODES[1599](VELOCITY_Y,0) = 0.000000; -NODES[1599](VELOCITY_Z,0) = 0.000000; -NODES[1600](VELOCITY_X,0) = 0.000000; -NODES[1600](VELOCITY_Y,0) = 0.000000; -NODES[1600](VELOCITY_Z,0) = 0.000000; -NODES[1601](VELOCITY_X,0) = 0.000000; -NODES[1601](VELOCITY_Y,0) = 0.000000; -NODES[1601](VELOCITY_Z,0) = 0.000000; -NODES[1602](VELOCITY_X,0) = 0.000000; -NODES[1602](VELOCITY_Y,0) = 0.000000; -NODES[1602](VELOCITY_Z,0) = 0.000000; -NODES[1603](VELOCITY_X,0) = 0.000000; -NODES[1603](VELOCITY_Y,0) = 0.000000; -NODES[1603](VELOCITY_Z,0) = 0.000000; -NODES[1604](VELOCITY_X,0) = 0.000000; -NODES[1604](VELOCITY_Y,0) = 0.000000; -NODES[1604](VELOCITY_Z,0) = 0.000000; -NODES[1605](VELOCITY_X,0) = 0.000000; -NODES[1605](VELOCITY_Y,0) = 0.000000; -NODES[1605](VELOCITY_Z,0) = 0.000000; -NODES[1607](VELOCITY_X,0) = 0.000000; -NODES[1607](VELOCITY_Y,0) = 0.000000; -NODES[1607](VELOCITY_Z,0) = 0.000000; -NODES[1608](VELOCITY_X,0) = 0.000000; -NODES[1608](VELOCITY_Y,0) = 0.000000; -NODES[1608](VELOCITY_Z,0) = 0.000000; -NODES[1609](VELOCITY_X,0) = 0.000000; -NODES[1609](VELOCITY_Y,0) = 0.000000; -NODES[1609](VELOCITY_Z,0) = 0.000000; -NODES[1611](VELOCITY_X,0) = 0.000000; -NODES[1611](VELOCITY_Y,0) = 0.000000; -NODES[1611](VELOCITY_Z,0) = 0.000000; -NODES[1612](VELOCITY_X,0) = 0.000000; -NODES[1612](VELOCITY_Y,0) = 0.000000; -NODES[1612](VELOCITY_Z,0) = 0.000000; -NODES[1614](VELOCITY_X,0) = 0.000000; -NODES[1614](VELOCITY_Y,0) = 0.000000; -NODES[1614](VELOCITY_Z,0) = 0.000000; -NODES[1615](VELOCITY_X,0) = 0.000000; -NODES[1615](VELOCITY_Y,0) = 0.000000; -NODES[1615](VELOCITY_Z,0) = 0.000000; -NODES[1617](VELOCITY_X,0) = 0.000000; -NODES[1617](VELOCITY_Y,0) = 0.000000; -NODES[1617](VELOCITY_Z,0) = 0.000000; -NODES[1619](VELOCITY_X,0) = 0.000000; -NODES[1619](VELOCITY_Y,0) = 0.000000; -NODES[1619](VELOCITY_Z,0) = 0.000000; -NODES[1620](VELOCITY_X,0) = 0.000000; -NODES[1620](VELOCITY_Y,0) = 0.000000; -NODES[1620](VELOCITY_Z,0) = 0.000000; -NODES[1622](VELOCITY_X,0) = 0.000000; -NODES[1622](VELOCITY_Y,0) = 0.000000; -NODES[1622](VELOCITY_Z,0) = 0.000000; -NODES[1623](VELOCITY_X,0) = 0.000000; -NODES[1623](VELOCITY_Y,0) = 0.000000; -NODES[1623](VELOCITY_Z,0) = 0.000000; -NODES[1624](VELOCITY_X,0) = 0.000000; -NODES[1624](VELOCITY_Y,0) = 0.000000; -NODES[1624](VELOCITY_Z,0) = 0.000000; -NODES[1626](VELOCITY_X,0) = 0.000000; -NODES[1626](VELOCITY_Y,0) = 0.000000; -NODES[1626](VELOCITY_Z,0) = 0.000000; -NODES[1627](VELOCITY_X,0) = 0.000000; -NODES[1627](VELOCITY_Y,0) = 0.000000; -NODES[1627](VELOCITY_Z,0) = 0.000000; -NODES[1628](VELOCITY_X,0) = 0.000000; -NODES[1628](VELOCITY_Y,0) = 0.000000; -NODES[1628](VELOCITY_Z,0) = 0.000000; -NODES[1629](VELOCITY_X,0) = 0.000000; -NODES[1629](VELOCITY_Y,0) = 0.000000; -NODES[1629](VELOCITY_Z,0) = 0.000000; -NODES[1630](VELOCITY_X,0) = 0.000000; -NODES[1630](VELOCITY_Y,0) = 0.000000; -NODES[1630](VELOCITY_Z,0) = 0.000000; -NODES[1631](VELOCITY_X,0) = 0.000000; -NODES[1631](VELOCITY_Y,0) = 0.000000; -NODES[1631](VELOCITY_Z,0) = 0.000000; -NODES[1632](VELOCITY_X,0) = 0.000000; -NODES[1632](VELOCITY_Y,0) = 0.000000; -NODES[1632](VELOCITY_Z,0) = 0.000000; -NODES[1633](VELOCITY_X,0) = 0.000000; -NODES[1633](VELOCITY_Y,0) = 0.000000; -NODES[1633](VELOCITY_Z,0) = 0.000000; -NODES[1634](VELOCITY_X,0) = 0.000000; -NODES[1634](VELOCITY_Y,0) = 0.000000; -NODES[1634](VELOCITY_Z,0) = 0.000000; -NODES[1635](VELOCITY_X,0) = 0.000000; -NODES[1635](VELOCITY_Y,0) = 0.000000; -NODES[1635](VELOCITY_Z,0) = 0.000000; -NODES[1636](VELOCITY_X,0) = 0.000000; -NODES[1636](VELOCITY_Y,0) = 0.000000; -NODES[1636](VELOCITY_Z,0) = 0.000000; -NODES[1637](VELOCITY_X,0) = 0.000000; -NODES[1637](VELOCITY_Y,0) = 0.000000; -NODES[1637](VELOCITY_Z,0) = 0.000000; -NODES[1638](VELOCITY_X,0) = 0.000000; -NODES[1638](VELOCITY_Y,0) = 0.000000; -NODES[1638](VELOCITY_Z,0) = 0.000000; -NODES[1640](VELOCITY_X,0) = 0.000000; -NODES[1640](VELOCITY_Y,0) = 0.000000; -NODES[1640](VELOCITY_Z,0) = 0.000000; -NODES[1642](VELOCITY_X,0) = 0.000000; -NODES[1642](VELOCITY_Y,0) = 0.000000; -NODES[1642](VELOCITY_Z,0) = 0.000000; -NODES[1643](VELOCITY_X,0) = 0.000000; -NODES[1643](VELOCITY_Y,0) = 0.000000; -NODES[1643](VELOCITY_Z,0) = 0.000000; -NODES[1645](VELOCITY_X,0) = 0.000000; -NODES[1645](VELOCITY_Y,0) = 0.000000; -NODES[1645](VELOCITY_Z,0) = 0.000000; -NODES[1646](VELOCITY_X,0) = 0.000000; -NODES[1646](VELOCITY_Y,0) = 0.000000; -NODES[1646](VELOCITY_Z,0) = 0.000000; -NODES[1647](VELOCITY_X,0) = 0.000000; -NODES[1647](VELOCITY_Y,0) = 0.000000; -NODES[1647](VELOCITY_Z,0) = 0.000000; -NODES[1648](VELOCITY_X,0) = 0.000000; -NODES[1648](VELOCITY_Y,0) = 0.000000; -NODES[1648](VELOCITY_Z,0) = 0.000000; -NODES[1649](VELOCITY_X,0) = 0.000000; -NODES[1649](VELOCITY_Y,0) = 0.000000; -NODES[1649](VELOCITY_Z,0) = 0.000000; -NODES[1650](VELOCITY_X,0) = 0.000000; -NODES[1650](VELOCITY_Y,0) = 0.000000; -NODES[1650](VELOCITY_Z,0) = 0.000000; -NODES[1651](VELOCITY_X,0) = 0.000000; -NODES[1651](VELOCITY_Y,0) = 0.000000; -NODES[1651](VELOCITY_Z,0) = 0.000000; -NODES[1652](VELOCITY_X,0) = 0.000000; -NODES[1652](VELOCITY_Y,0) = 0.000000; -NODES[1652](VELOCITY_Z,0) = 0.000000; -NODES[1653](VELOCITY_X,0) = 0.000000; -NODES[1653](VELOCITY_Y,0) = 0.000000; -NODES[1653](VELOCITY_Z,0) = 0.000000; -NODES[1654](VELOCITY_X,0) = 0.000000; -NODES[1654](VELOCITY_Y,0) = 0.000000; -NODES[1654](VELOCITY_Z,0) = 0.000000; -NODES[1655](VELOCITY_X,0) = 0.000000; -NODES[1655](VELOCITY_Y,0) = 0.000000; -NODES[1655](VELOCITY_Z,0) = 0.000000; -NODES[1656](VELOCITY_X,0) = 0.000000; -NODES[1656](VELOCITY_Y,0) = 0.000000; -NODES[1656](VELOCITY_Z,0) = 0.000000; -NODES[1657](VELOCITY_X,0) = 0.000000; -NODES[1657](VELOCITY_Y,0) = 0.000000; -NODES[1657](VELOCITY_Z,0) = 0.000000; -NODES[1658](VELOCITY_X,0) = 0.000000; -NODES[1658](VELOCITY_Y,0) = 0.000000; -NODES[1658](VELOCITY_Z,0) = 0.000000; -NODES[1661](VELOCITY_X,0) = 0.000000; -NODES[1661](VELOCITY_Y,0) = 0.000000; -NODES[1661](VELOCITY_Z,0) = 0.000000; -NODES[1662](VELOCITY_X,0) = 0.000000; -NODES[1662](VELOCITY_Y,0) = 0.000000; -NODES[1662](VELOCITY_Z,0) = 0.000000; -NODES[1663](VELOCITY_X,0) = 0.000000; -NODES[1663](VELOCITY_Y,0) = 0.000000; -NODES[1663](VELOCITY_Z,0) = 0.000000; -NODES[1665](VELOCITY_X,0) = 0.000000; -NODES[1665](VELOCITY_Y,0) = 0.000000; -NODES[1665](VELOCITY_Z,0) = 0.000000; -NODES[1666](VELOCITY_X,0) = 0.000000; -NODES[1666](VELOCITY_Y,0) = 0.000000; -NODES[1666](VELOCITY_Z,0) = 0.000000; -NODES[1667](VELOCITY_X,0) = 0.000000; -NODES[1667](VELOCITY_Y,0) = 0.000000; -NODES[1667](VELOCITY_Z,0) = 0.000000; -NODES[1668](VELOCITY_X,0) = 0.000000; -NODES[1668](VELOCITY_Y,0) = 0.000000; -NODES[1668](VELOCITY_Z,0) = 0.000000; -NODES[1669](VELOCITY_X,0) = 0.000000; -NODES[1669](VELOCITY_Y,0) = 0.000000; -NODES[1669](VELOCITY_Z,0) = 0.000000; -NODES[1670](VELOCITY_X,0) = 0.000000; -NODES[1670](VELOCITY_Y,0) = 0.000000; -NODES[1670](VELOCITY_Z,0) = 0.000000; -NODES[1672](VELOCITY_X,0) = 0.000000; -NODES[1672](VELOCITY_Y,0) = 0.000000; -NODES[1672](VELOCITY_Z,0) = 0.000000; -NODES[1673](VELOCITY_X,0) = 0.000000; -NODES[1673](VELOCITY_Y,0) = 0.000000; -NODES[1673](VELOCITY_Z,0) = 0.000000; -NODES[1674](VELOCITY_X,0) = 0.000000; -NODES[1674](VELOCITY_Y,0) = 0.000000; -NODES[1674](VELOCITY_Z,0) = 0.000000; -NODES[1675](VELOCITY_X,0) = 0.000000; -NODES[1675](VELOCITY_Y,0) = 0.000000; -NODES[1675](VELOCITY_Z,0) = 0.000000; -NODES[1676](VELOCITY_X,0) = 0.000000; -NODES[1676](VELOCITY_Y,0) = 0.000000; -NODES[1676](VELOCITY_Z,0) = 0.000000; -NODES[1678](VELOCITY_X,0) = 0.000000; -NODES[1678](VELOCITY_Y,0) = 0.000000; -NODES[1678](VELOCITY_Z,0) = 0.000000; -NODES[1679](VELOCITY_X,0) = 0.000000; -NODES[1679](VELOCITY_Y,0) = 0.000000; -NODES[1679](VELOCITY_Z,0) = 0.000000; -NODES[1682](VELOCITY_X,0) = 0.000000; -NODES[1682](VELOCITY_Y,0) = 0.000000; -NODES[1682](VELOCITY_Z,0) = 0.000000; -NODES[1683](VELOCITY_X,0) = 0.000000; -NODES[1683](VELOCITY_Y,0) = 0.000000; -NODES[1683](VELOCITY_Z,0) = 0.000000; -NODES[1684](VELOCITY_X,0) = 0.000000; -NODES[1684](VELOCITY_Y,0) = 0.000000; -NODES[1684](VELOCITY_Z,0) = 0.000000; -NODES[1685](VELOCITY_X,0) = 0.000000; -NODES[1685](VELOCITY_Y,0) = 0.000000; -NODES[1685](VELOCITY_Z,0) = 0.000000; -NODES[1686](VELOCITY_X,0) = 0.000000; -NODES[1686](VELOCITY_Y,0) = 0.000000; -NODES[1686](VELOCITY_Z,0) = 0.000000; -NODES[1687](VELOCITY_X,0) = 0.000000; -NODES[1687](VELOCITY_Y,0) = 0.000000; -NODES[1687](VELOCITY_Z,0) = 0.000000; -NODES[1688](VELOCITY_X,0) = 0.000000; -NODES[1688](VELOCITY_Y,0) = 0.000000; -NODES[1688](VELOCITY_Z,0) = 0.000000; -NODES[1689](VELOCITY_X,0) = 0.000000; -NODES[1689](VELOCITY_Y,0) = 0.000000; -NODES[1689](VELOCITY_Z,0) = 0.000000; -NODES[1690](VELOCITY_X,0) = 0.000000; -NODES[1690](VELOCITY_Y,0) = 0.000000; -NODES[1690](VELOCITY_Z,0) = 0.000000; -NODES[1691](VELOCITY_X,0) = 0.000000; -NODES[1691](VELOCITY_Y,0) = 0.000000; -NODES[1691](VELOCITY_Z,0) = 0.000000; -NODES[1692](VELOCITY_X,0) = 0.000000; -NODES[1692](VELOCITY_Y,0) = 0.000000; -NODES[1692](VELOCITY_Z,0) = 0.000000; -NODES[1694](VELOCITY_X,0) = 0.000000; -NODES[1694](VELOCITY_Y,0) = 0.000000; -NODES[1694](VELOCITY_Z,0) = 0.000000; -NODES[1695](VELOCITY_X,0) = 0.000000; -NODES[1695](VELOCITY_Y,0) = 0.000000; -NODES[1695](VELOCITY_Z,0) = 0.000000; -NODES[1696](VELOCITY_X,0) = 0.000000; -NODES[1696](VELOCITY_Y,0) = 0.000000; -NODES[1696](VELOCITY_Z,0) = 0.000000; -NODES[1699](VELOCITY_X,0) = 0.000000; -NODES[1699](VELOCITY_Y,0) = 0.000000; -NODES[1699](VELOCITY_Z,0) = 0.000000; -NODES[1700](VELOCITY_X,0) = 0.000000; -NODES[1700](VELOCITY_Y,0) = 0.000000; -NODES[1700](VELOCITY_Z,0) = 0.000000; -NODES[1701](VELOCITY_X,0) = 0.000000; -NODES[1701](VELOCITY_Y,0) = 0.000000; -NODES[1701](VELOCITY_Z,0) = 0.000000; -NODES[1703](VELOCITY_X,0) = 0.000000; -NODES[1703](VELOCITY_Y,0) = 0.000000; -NODES[1703](VELOCITY_Z,0) = 0.000000; -NODES[1704](VELOCITY_X,0) = 0.000000; -NODES[1704](VELOCITY_Y,0) = 0.000000; -NODES[1704](VELOCITY_Z,0) = 0.000000; -NODES[1707](VELOCITY_X,0) = 0.000000; -NODES[1707](VELOCITY_Y,0) = 0.000000; -NODES[1707](VELOCITY_Z,0) = 0.000000; -NODES[1708](VELOCITY_X,0) = 0.000000; -NODES[1708](VELOCITY_Y,0) = 0.000000; -NODES[1708](VELOCITY_Z,0) = 0.000000; -NODES[1709](VELOCITY_X,0) = 0.000000; -NODES[1709](VELOCITY_Y,0) = 0.000000; -NODES[1709](VELOCITY_Z,0) = 0.000000; -NODES[1710](VELOCITY_X,0) = 0.000000; -NODES[1710](VELOCITY_Y,0) = 0.000000; -NODES[1710](VELOCITY_Z,0) = 0.000000; -NODES[1714](VELOCITY_X,0) = 0.000000; -NODES[1714](VELOCITY_Y,0) = 0.000000; -NODES[1714](VELOCITY_Z,0) = 0.000000; -NODES[1716](VELOCITY_X,0) = 0.000000; -NODES[1716](VELOCITY_Y,0) = 0.000000; -NODES[1716](VELOCITY_Z,0) = 0.000000; -NODES[1718](VELOCITY_X,0) = 0.000000; -NODES[1718](VELOCITY_Y,0) = 0.000000; -NODES[1718](VELOCITY_Z,0) = 0.000000; -NODES[1719](VELOCITY_X,0) = 0.000000; -NODES[1719](VELOCITY_Y,0) = 0.000000; -NODES[1719](VELOCITY_Z,0) = 0.000000; -NODES[1720](VELOCITY_X,0) = 0.000000; -NODES[1720](VELOCITY_Y,0) = 0.000000; -NODES[1720](VELOCITY_Z,0) = 0.000000; -NODES[1724](VELOCITY_X,0) = 0.000000; -NODES[1724](VELOCITY_Y,0) = 0.000000; -NODES[1724](VELOCITY_Z,0) = 0.000000; -NODES[1725](VELOCITY_X,0) = 0.000000; -NODES[1725](VELOCITY_Y,0) = 0.000000; -NODES[1725](VELOCITY_Z,0) = 0.000000; -NODES[1726](VELOCITY_X,0) = 0.000000; -NODES[1726](VELOCITY_Y,0) = 0.000000; -NODES[1726](VELOCITY_Z,0) = 0.000000; -NODES[1730](VELOCITY_X,0) = 0.000000; -NODES[1730](VELOCITY_Y,0) = 0.000000; -NODES[1730](VELOCITY_Z,0) = 0.000000; -NODES[1731](VELOCITY_X,0) = 0.000000; -NODES[1731](VELOCITY_Y,0) = 0.000000; -NODES[1731](VELOCITY_Z,0) = 0.000000; -NODES[1732](VELOCITY_X,0) = 0.000000; -NODES[1732](VELOCITY_Y,0) = 0.000000; -NODES[1732](VELOCITY_Z,0) = 0.000000; -NODES[1733](VELOCITY_X,0) = 0.000000; -NODES[1733](VELOCITY_Y,0) = 0.000000; -NODES[1733](VELOCITY_Z,0) = 0.000000; -NODES[1734](VELOCITY_X,0) = 0.000000; -NODES[1734](VELOCITY_Y,0) = 0.000000; -NODES[1734](VELOCITY_Z,0) = 0.000000; -NODES[1735](VELOCITY_X,0) = 0.000000; -NODES[1735](VELOCITY_Y,0) = 0.000000; -NODES[1735](VELOCITY_Z,0) = 0.000000; -NODES[1736](VELOCITY_X,0) = 0.000000; -NODES[1736](VELOCITY_Y,0) = 0.000000; -NODES[1736](VELOCITY_Z,0) = 0.000000; -NODES[1737](VELOCITY_X,0) = 0.000000; -NODES[1737](VELOCITY_Y,0) = 0.000000; -NODES[1737](VELOCITY_Z,0) = 0.000000; -NODES[1738](VELOCITY_X,0) = 0.000000; -NODES[1738](VELOCITY_Y,0) = 0.000000; -NODES[1738](VELOCITY_Z,0) = 0.000000; -NODES[1741](VELOCITY_X,0) = 0.000000; -NODES[1741](VELOCITY_Y,0) = 0.000000; -NODES[1741](VELOCITY_Z,0) = 0.000000; -NODES[1742](VELOCITY_X,0) = 0.000000; -NODES[1742](VELOCITY_Y,0) = 0.000000; -NODES[1742](VELOCITY_Z,0) = 0.000000; -NODES[1743](VELOCITY_X,0) = 0.000000; -NODES[1743](VELOCITY_Y,0) = 0.000000; -NODES[1743](VELOCITY_Z,0) = 0.000000; -NODES[1745](VELOCITY_X,0) = 0.000000; -NODES[1745](VELOCITY_Y,0) = 0.000000; -NODES[1745](VELOCITY_Z,0) = 0.000000; -NODES[1747](VELOCITY_X,0) = 0.000000; -NODES[1747](VELOCITY_Y,0) = 0.000000; -NODES[1747](VELOCITY_Z,0) = 0.000000; -NODES[1748](VELOCITY_X,0) = 0.000000; -NODES[1748](VELOCITY_Y,0) = 0.000000; -NODES[1748](VELOCITY_Z,0) = 0.000000; -NODES[1749](VELOCITY_X,0) = 0.000000; -NODES[1749](VELOCITY_Y,0) = 0.000000; -NODES[1749](VELOCITY_Z,0) = 0.000000; -NODES[1750](VELOCITY_X,0) = 0.000000; -NODES[1750](VELOCITY_Y,0) = 0.000000; -NODES[1750](VELOCITY_Z,0) = 0.000000; -NODES[1753](VELOCITY_X,0) = 0.000000; -NODES[1753](VELOCITY_Y,0) = 0.000000; -NODES[1753](VELOCITY_Z,0) = 0.000000; -NODES[1754](VELOCITY_X,0) = 0.000000; -NODES[1754](VELOCITY_Y,0) = 0.000000; -NODES[1754](VELOCITY_Z,0) = 0.000000; -NODES[1755](VELOCITY_X,0) = 0.000000; -NODES[1755](VELOCITY_Y,0) = 0.000000; -NODES[1755](VELOCITY_Z,0) = 0.000000; -NODES[1757](VELOCITY_X,0) = 0.000000; -NODES[1757](VELOCITY_Y,0) = 0.000000; -NODES[1757](VELOCITY_Z,0) = 0.000000; -NODES[1758](VELOCITY_X,0) = 0.000000; -NODES[1758](VELOCITY_Y,0) = 0.000000; -NODES[1758](VELOCITY_Z,0) = 0.000000; -NODES[1760](VELOCITY_X,0) = 0.000000; -NODES[1760](VELOCITY_Y,0) = 0.000000; -NODES[1760](VELOCITY_Z,0) = 0.000000; -NODES[1761](VELOCITY_X,0) = 0.000000; -NODES[1761](VELOCITY_Y,0) = 0.000000; -NODES[1761](VELOCITY_Z,0) = 0.000000; -NODES[1762](VELOCITY_X,0) = 0.000000; -NODES[1762](VELOCITY_Y,0) = 0.000000; -NODES[1762](VELOCITY_Z,0) = 0.000000; -NODES[1763](VELOCITY_X,0) = 0.000000; -NODES[1763](VELOCITY_Y,0) = 0.000000; -NODES[1763](VELOCITY_Z,0) = 0.000000; -NODES[1764](VELOCITY_X,0) = 0.000000; -NODES[1764](VELOCITY_Y,0) = 0.000000; -NODES[1764](VELOCITY_Z,0) = 0.000000; -NODES[1765](VELOCITY_X,0) = 0.000000; -NODES[1765](VELOCITY_Y,0) = 0.000000; -NODES[1765](VELOCITY_Z,0) = 0.000000; -NODES[1766](VELOCITY_X,0) = 0.000000; -NODES[1766](VELOCITY_Y,0) = 0.000000; -NODES[1766](VELOCITY_Z,0) = 0.000000; -NODES[1768](VELOCITY_X,0) = 0.000000; -NODES[1768](VELOCITY_Y,0) = 0.000000; -NODES[1768](VELOCITY_Z,0) = 0.000000; -NODES[1769](VELOCITY_X,0) = 0.000000; -NODES[1769](VELOCITY_Y,0) = 0.000000; -NODES[1769](VELOCITY_Z,0) = 0.000000; -NODES[1770](VELOCITY_X,0) = 0.000000; -NODES[1770](VELOCITY_Y,0) = 0.000000; -NODES[1770](VELOCITY_Z,0) = 0.000000; -NODES[1771](VELOCITY_X,0) = 0.000000; -NODES[1771](VELOCITY_Y,0) = 0.000000; -NODES[1771](VELOCITY_Z,0) = 0.000000; -NODES[1772](VELOCITY_X,0) = 0.000000; -NODES[1772](VELOCITY_Y,0) = 0.000000; -NODES[1772](VELOCITY_Z,0) = 0.000000; -NODES[1773](VELOCITY_X,0) = 0.000000; -NODES[1773](VELOCITY_Y,0) = 0.000000; -NODES[1773](VELOCITY_Z,0) = 0.000000; -NODES[1774](VELOCITY_X,0) = 0.000000; -NODES[1774](VELOCITY_Y,0) = 0.000000; -NODES[1774](VELOCITY_Z,0) = 0.000000; -NODES[1775](VELOCITY_X,0) = 0.000000; -NODES[1775](VELOCITY_Y,0) = 0.000000; -NODES[1775](VELOCITY_Z,0) = 0.000000; -NODES[1776](VELOCITY_X,0) = 0.000000; -NODES[1776](VELOCITY_Y,0) = 0.000000; -NODES[1776](VELOCITY_Z,0) = 0.000000; -NODES[1777](VELOCITY_X,0) = 0.000000; -NODES[1777](VELOCITY_Y,0) = 0.000000; -NODES[1777](VELOCITY_Z,0) = 0.000000; -NODES[1778](VELOCITY_X,0) = 0.000000; -NODES[1778](VELOCITY_Y,0) = 0.000000; -NODES[1778](VELOCITY_Z,0) = 0.000000; -NODES[1779](VELOCITY_X,0) = 0.000000; -NODES[1779](VELOCITY_Y,0) = 0.000000; -NODES[1779](VELOCITY_Z,0) = 0.000000; -NODES[1780](VELOCITY_X,0) = 0.000000; -NODES[1780](VELOCITY_Y,0) = 0.000000; -NODES[1780](VELOCITY_Z,0) = 0.000000; -NODES[1781](VELOCITY_X,0) = 0.000000; -NODES[1781](VELOCITY_Y,0) = 0.000000; -NODES[1781](VELOCITY_Z,0) = 0.000000; -NODES[1784](VELOCITY_X,0) = 0.000000; -NODES[1784](VELOCITY_Y,0) = 0.000000; -NODES[1784](VELOCITY_Z,0) = 0.000000; -NODES[1787](VELOCITY_X,0) = 0.000000; -NODES[1787](VELOCITY_Y,0) = 0.000000; -NODES[1787](VELOCITY_Z,0) = 0.000000; -NODES[1788](VELOCITY_X,0) = 0.000000; -NODES[1788](VELOCITY_Y,0) = 0.000000; -NODES[1788](VELOCITY_Z,0) = 0.000000; -NODES[1790](VELOCITY_X,0) = 0.000000; -NODES[1790](VELOCITY_Y,0) = 0.000000; -NODES[1790](VELOCITY_Z,0) = 0.000000; -NODES[1792](VELOCITY_X,0) = 0.000000; -NODES[1792](VELOCITY_Y,0) = 0.000000; -NODES[1792](VELOCITY_Z,0) = 0.000000; -NODES[1793](VELOCITY_X,0) = 0.000000; -NODES[1793](VELOCITY_Y,0) = 0.000000; -NODES[1793](VELOCITY_Z,0) = 0.000000; -NODES[1794](VELOCITY_X,0) = 0.000000; -NODES[1794](VELOCITY_Y,0) = 0.000000; -NODES[1794](VELOCITY_Z,0) = 0.000000; -NODES[1796](VELOCITY_X,0) = 0.000000; -NODES[1796](VELOCITY_Y,0) = 0.000000; -NODES[1796](VELOCITY_Z,0) = 0.000000; -NODES[1797](VELOCITY_X,0) = 0.000000; -NODES[1797](VELOCITY_Y,0) = 0.000000; -NODES[1797](VELOCITY_Z,0) = 0.000000; -NODES[1798](VELOCITY_X,0) = 0.000000; -NODES[1798](VELOCITY_Y,0) = 0.000000; -NODES[1798](VELOCITY_Z,0) = 0.000000; -NODES[1799](VELOCITY_X,0) = 0.000000; -NODES[1799](VELOCITY_Y,0) = 0.000000; -NODES[1799](VELOCITY_Z,0) = 0.000000; -NODES[1800](VELOCITY_X,0) = 0.000000; -NODES[1800](VELOCITY_Y,0) = 0.000000; -NODES[1800](VELOCITY_Z,0) = 0.000000; -NODES[1805](VELOCITY_X,0) = 0.000000; -NODES[1805](VELOCITY_Y,0) = 0.000000; -NODES[1805](VELOCITY_Z,0) = 0.000000; -NODES[1806](VELOCITY_X,0) = 0.000000; -NODES[1806](VELOCITY_Y,0) = 0.000000; -NODES[1806](VELOCITY_Z,0) = 0.000000; -NODES[1810](VELOCITY_X,0) = 0.000000; -NODES[1810](VELOCITY_Y,0) = 0.000000; -NODES[1810](VELOCITY_Z,0) = 0.000000; -NODES[1813](VELOCITY_X,0) = 0.000000; -NODES[1813](VELOCITY_Y,0) = 0.000000; -NODES[1813](VELOCITY_Z,0) = 0.000000; -NODES[1815](VELOCITY_X,0) = 0.000000; -NODES[1815](VELOCITY_Y,0) = 0.000000; -NODES[1815](VELOCITY_Z,0) = 0.000000; -NODES[1817](VELOCITY_X,0) = 0.000000; -NODES[1817](VELOCITY_Y,0) = 0.000000; -NODES[1817](VELOCITY_Z,0) = 0.000000; -NODES[1819](VELOCITY_X,0) = 0.000000; -NODES[1819](VELOCITY_Y,0) = 0.000000; -NODES[1819](VELOCITY_Z,0) = 0.000000; -NODES[1820](VELOCITY_X,0) = 0.000000; -NODES[1820](VELOCITY_Y,0) = 0.000000; -NODES[1820](VELOCITY_Z,0) = 0.000000; -NODES[1822](VELOCITY_X,0) = 0.000000; -NODES[1822](VELOCITY_Y,0) = 0.000000; -NODES[1822](VELOCITY_Z,0) = 0.000000; -NODES[1824](VELOCITY_X,0) = 0.000000; -NODES[1824](VELOCITY_Y,0) = 0.000000; -NODES[1824](VELOCITY_Z,0) = 0.000000; -NODES[1825](VELOCITY_X,0) = 0.000000; -NODES[1825](VELOCITY_Y,0) = 0.000000; -NODES[1825](VELOCITY_Z,0) = 0.000000; -NODES[1826](VELOCITY_X,0) = 0.000000; -NODES[1826](VELOCITY_Y,0) = 0.000000; -NODES[1826](VELOCITY_Z,0) = 0.000000; -NODES[1827](VELOCITY_X,0) = 0.000000; -NODES[1827](VELOCITY_Y,0) = 0.000000; -NODES[1827](VELOCITY_Z,0) = 0.000000; -NODES[1830](VELOCITY_X,0) = 0.000000; -NODES[1830](VELOCITY_Y,0) = 0.000000; -NODES[1830](VELOCITY_Z,0) = 0.000000; -NODES[1834](VELOCITY_X,0) = 0.000000; -NODES[1834](VELOCITY_Y,0) = 0.000000; -NODES[1834](VELOCITY_Z,0) = 0.000000; -NODES[1835](VELOCITY_X,0) = 0.000000; -NODES[1835](VELOCITY_Y,0) = 0.000000; -NODES[1835](VELOCITY_Z,0) = 0.000000; -NODES[1837](VELOCITY_X,0) = 0.000000; -NODES[1837](VELOCITY_Y,0) = 0.000000; -NODES[1837](VELOCITY_Z,0) = 0.000000; -NODES[1838](VELOCITY_X,0) = 0.000000; -NODES[1838](VELOCITY_Y,0) = 0.000000; -NODES[1838](VELOCITY_Z,0) = 0.000000; -NODES[1841](VELOCITY_X,0) = 0.000000; -NODES[1841](VELOCITY_Y,0) = 0.000000; -NODES[1841](VELOCITY_Z,0) = 0.000000; -NODES[1842](VELOCITY_X,0) = 0.000000; -NODES[1842](VELOCITY_Y,0) = 0.000000; -NODES[1842](VELOCITY_Z,0) = 0.000000; -NODES[1843](VELOCITY_X,0) = 0.000000; -NODES[1843](VELOCITY_Y,0) = 0.000000; -NODES[1843](VELOCITY_Z,0) = 0.000000; -NODES[1844](VELOCITY_X,0) = 0.000000; -NODES[1844](VELOCITY_Y,0) = 0.000000; -NODES[1844](VELOCITY_Z,0) = 0.000000; -NODES[1845](VELOCITY_X,0) = 0.000000; -NODES[1845](VELOCITY_Y,0) = 0.000000; -NODES[1845](VELOCITY_Z,0) = 0.000000; -NODES[1847](VELOCITY_X,0) = 0.000000; -NODES[1847](VELOCITY_Y,0) = 0.000000; -NODES[1847](VELOCITY_Z,0) = 0.000000; -NODES[1850](VELOCITY_X,0) = 0.000000; -NODES[1850](VELOCITY_Y,0) = 0.000000; -NODES[1850](VELOCITY_Z,0) = 0.000000; -NODES[1851](VELOCITY_X,0) = 0.000000; -NODES[1851](VELOCITY_Y,0) = 0.000000; -NODES[1851](VELOCITY_Z,0) = 0.000000; -NODES[1852](VELOCITY_X,0) = 0.000000; -NODES[1852](VELOCITY_Y,0) = 0.000000; -NODES[1852](VELOCITY_Z,0) = 0.000000; -NODES[1853](VELOCITY_X,0) = 0.000000; -NODES[1853](VELOCITY_Y,0) = 0.000000; -NODES[1853](VELOCITY_Z,0) = 0.000000; -NODES[1855](VELOCITY_X,0) = 0.000000; -NODES[1855](VELOCITY_Y,0) = 0.000000; -NODES[1855](VELOCITY_Z,0) = 0.000000; -NODES[1857](VELOCITY_X,0) = 0.000000; -NODES[1857](VELOCITY_Y,0) = 0.000000; -NODES[1857](VELOCITY_Z,0) = 0.000000; -NODES[1858](VELOCITY_X,0) = 0.000000; -NODES[1858](VELOCITY_Y,0) = 0.000000; -NODES[1858](VELOCITY_Z,0) = 0.000000; -NODES[1859](VELOCITY_X,0) = 0.000000; -NODES[1859](VELOCITY_Y,0) = 0.000000; -NODES[1859](VELOCITY_Z,0) = 0.000000; -NODES[1860](VELOCITY_X,0) = 0.000000; -NODES[1860](VELOCITY_Y,0) = 0.000000; -NODES[1860](VELOCITY_Z,0) = 0.000000; -NODES[1863](VELOCITY_X,0) = 0.000000; -NODES[1863](VELOCITY_Y,0) = 0.000000; -NODES[1863](VELOCITY_Z,0) = 0.000000; -NODES[1864](VELOCITY_X,0) = 0.000000; -NODES[1864](VELOCITY_Y,0) = 0.000000; -NODES[1864](VELOCITY_Z,0) = 0.000000; -NODES[1865](VELOCITY_X,0) = 0.000000; -NODES[1865](VELOCITY_Y,0) = 0.000000; -NODES[1865](VELOCITY_Z,0) = 0.000000; -NODES[1866](VELOCITY_X,0) = 0.000000; -NODES[1866](VELOCITY_Y,0) = 0.000000; -NODES[1866](VELOCITY_Z,0) = 0.000000; -NODES[1867](VELOCITY_X,0) = 0.000000; -NODES[1867](VELOCITY_Y,0) = 0.000000; -NODES[1867](VELOCITY_Z,0) = 0.000000; -NODES[1871](VELOCITY_X,0) = 0.000000; -NODES[1871](VELOCITY_Y,0) = 0.000000; -NODES[1871](VELOCITY_Z,0) = 0.000000; -NODES[1877](VELOCITY_X,0) = 0.000000; -NODES[1877](VELOCITY_Y,0) = 0.000000; -NODES[1877](VELOCITY_Z,0) = 0.000000; -NODES[1882](VELOCITY_X,0) = 0.000000; -NODES[1882](VELOCITY_Y,0) = 0.000000; -NODES[1882](VELOCITY_Z,0) = 0.000000; -NODES[1883](VELOCITY_X,0) = 0.000000; -NODES[1883](VELOCITY_Y,0) = 0.000000; -NODES[1883](VELOCITY_Z,0) = 0.000000; -NODES[1884](VELOCITY_X,0) = 0.000000; -NODES[1884](VELOCITY_Y,0) = 0.000000; -NODES[1884](VELOCITY_Z,0) = 0.000000; -NODES[1886](VELOCITY_X,0) = 0.000000; -NODES[1886](VELOCITY_Y,0) = 0.000000; -NODES[1886](VELOCITY_Z,0) = 0.000000; -NODES[1890](VELOCITY_X,0) = 0.000000; -NODES[1890](VELOCITY_Y,0) = 0.000000; -NODES[1890](VELOCITY_Z,0) = 0.000000; -NODES[1891](VELOCITY_X,0) = 0.000000; -NODES[1891](VELOCITY_Y,0) = 0.000000; -NODES[1891](VELOCITY_Z,0) = 0.000000; -NODES[1892](VELOCITY_X,0) = 0.000000; -NODES[1892](VELOCITY_Y,0) = 0.000000; -NODES[1892](VELOCITY_Z,0) = 0.000000; -NODES[1894](VELOCITY_X,0) = 0.000000; -NODES[1894](VELOCITY_Y,0) = 0.000000; -NODES[1894](VELOCITY_Z,0) = 0.000000; -NODES[1895](VELOCITY_X,0) = 0.000000; -NODES[1895](VELOCITY_Y,0) = 0.000000; -NODES[1895](VELOCITY_Z,0) = 0.000000; -NODES[1896](VELOCITY_X,0) = 0.000000; -NODES[1896](VELOCITY_Y,0) = 0.000000; -NODES[1896](VELOCITY_Z,0) = 0.000000; -NODES[1898](VELOCITY_X,0) = 0.000000; -NODES[1898](VELOCITY_Y,0) = 0.000000; -NODES[1898](VELOCITY_Z,0) = 0.000000; -NODES[1899](VELOCITY_X,0) = 0.000000; -NODES[1899](VELOCITY_Y,0) = 0.000000; -NODES[1899](VELOCITY_Z,0) = 0.000000; -NODES[1900](VELOCITY_X,0) = 0.000000; -NODES[1900](VELOCITY_Y,0) = 0.000000; -NODES[1900](VELOCITY_Z,0) = 0.000000; -NODES[1901](VELOCITY_X,0) = 0.000000; -NODES[1901](VELOCITY_Y,0) = 0.000000; -NODES[1901](VELOCITY_Z,0) = 0.000000; -NODES[1902](VELOCITY_X,0) = 0.000000; -NODES[1902](VELOCITY_Y,0) = 0.000000; -NODES[1902](VELOCITY_Z,0) = 0.000000; -NODES[1903](VELOCITY_X,0) = 0.000000; -NODES[1903](VELOCITY_Y,0) = 0.000000; -NODES[1903](VELOCITY_Z,0) = 0.000000; -NODES[1904](VELOCITY_X,0) = 0.000000; -NODES[1904](VELOCITY_Y,0) = 0.000000; -NODES[1904](VELOCITY_Z,0) = 0.000000; -NODES[1905](VELOCITY_X,0) = 0.000000; -NODES[1905](VELOCITY_Y,0) = 0.000000; -NODES[1905](VELOCITY_Z,0) = 0.000000; -NODES[1908](VELOCITY_X,0) = 0.000000; -NODES[1908](VELOCITY_Y,0) = 0.000000; -NODES[1908](VELOCITY_Z,0) = 0.000000; -NODES[1909](VELOCITY_X,0) = 0.000000; -NODES[1909](VELOCITY_Y,0) = 0.000000; -NODES[1909](VELOCITY_Z,0) = 0.000000; -NODES[1912](VELOCITY_X,0) = 0.000000; -NODES[1912](VELOCITY_Y,0) = 0.000000; -NODES[1912](VELOCITY_Z,0) = 0.000000; -NODES[1914](VELOCITY_X,0) = 0.000000; -NODES[1914](VELOCITY_Y,0) = 0.000000; -NODES[1914](VELOCITY_Z,0) = 0.000000; -NODES[1918](VELOCITY_X,0) = 0.000000; -NODES[1918](VELOCITY_Y,0) = 0.000000; -NODES[1918](VELOCITY_Z,0) = 0.000000; -NODES[1920](VELOCITY_X,0) = 0.000000; -NODES[1920](VELOCITY_Y,0) = 0.000000; -NODES[1920](VELOCITY_Z,0) = 0.000000; -NODES[1921](VELOCITY_X,0) = 0.000000; -NODES[1921](VELOCITY_Y,0) = 0.000000; -NODES[1921](VELOCITY_Z,0) = 0.000000; -NODES[1923](VELOCITY_X,0) = 0.000000; -NODES[1923](VELOCITY_Y,0) = 0.000000; -NODES[1923](VELOCITY_Z,0) = 0.000000; -NODES[1925](VELOCITY_X,0) = 0.000000; -NODES[1925](VELOCITY_Y,0) = 0.000000; -NODES[1925](VELOCITY_Z,0) = 0.000000; -NODES[1926](VELOCITY_X,0) = 0.000000; -NODES[1926](VELOCITY_Y,0) = 0.000000; -NODES[1926](VELOCITY_Z,0) = 0.000000; -NODES[1927](VELOCITY_X,0) = 0.000000; -NODES[1927](VELOCITY_Y,0) = 0.000000; -NODES[1927](VELOCITY_Z,0) = 0.000000; -NODES[1929](VELOCITY_X,0) = 0.000000; -NODES[1929](VELOCITY_Y,0) = 0.000000; -NODES[1929](VELOCITY_Z,0) = 0.000000; -NODES[1930](VELOCITY_X,0) = 0.000000; -NODES[1930](VELOCITY_Y,0) = 0.000000; -NODES[1930](VELOCITY_Z,0) = 0.000000; -NODES[1934](VELOCITY_X,0) = 0.000000; -NODES[1934](VELOCITY_Y,0) = 0.000000; -NODES[1934](VELOCITY_Z,0) = 0.000000; -NODES[1935](VELOCITY_X,0) = 0.000000; -NODES[1935](VELOCITY_Y,0) = 0.000000; -NODES[1935](VELOCITY_Z,0) = 0.000000; -NODES[1936](VELOCITY_X,0) = 0.000000; -NODES[1936](VELOCITY_Y,0) = 0.000000; -NODES[1936](VELOCITY_Z,0) = 0.000000; -NODES[1937](VELOCITY_X,0) = 0.000000; -NODES[1937](VELOCITY_Y,0) = 0.000000; -NODES[1937](VELOCITY_Z,0) = 0.000000; -NODES[1940](VELOCITY_X,0) = 0.000000; -NODES[1940](VELOCITY_Y,0) = 0.000000; -NODES[1940](VELOCITY_Z,0) = 0.000000; -NODES[1943](VELOCITY_X,0) = 0.000000; -NODES[1943](VELOCITY_Y,0) = 0.000000; -NODES[1943](VELOCITY_Z,0) = 0.000000; -NODES[1944](VELOCITY_X,0) = 0.000000; -NODES[1944](VELOCITY_Y,0) = 0.000000; -NODES[1944](VELOCITY_Z,0) = 0.000000; -NODES[1945](VELOCITY_X,0) = 0.000000; -NODES[1945](VELOCITY_Y,0) = 0.000000; -NODES[1945](VELOCITY_Z,0) = 0.000000; -NODES[1946](VELOCITY_X,0) = 0.000000; -NODES[1946](VELOCITY_Y,0) = 0.000000; -NODES[1946](VELOCITY_Z,0) = 0.000000; -NODES[1947](VELOCITY_X,0) = 0.000000; -NODES[1947](VELOCITY_Y,0) = 0.000000; -NODES[1947](VELOCITY_Z,0) = 0.000000; -NODES[1950](VELOCITY_X,0) = 0.000000; -NODES[1950](VELOCITY_Y,0) = 0.000000; -NODES[1950](VELOCITY_Z,0) = 0.000000; -NODES[1951](VELOCITY_X,0) = 0.000000; -NODES[1951](VELOCITY_Y,0) = 0.000000; -NODES[1951](VELOCITY_Z,0) = 0.000000; -NODES[1953](VELOCITY_X,0) = 0.000000; -NODES[1953](VELOCITY_Y,0) = 0.000000; -NODES[1953](VELOCITY_Z,0) = 0.000000; -NODES[1954](VELOCITY_X,0) = 0.000000; -NODES[1954](VELOCITY_Y,0) = 0.000000; -NODES[1954](VELOCITY_Z,0) = 0.000000; -NODES[1957](VELOCITY_X,0) = 0.000000; -NODES[1957](VELOCITY_Y,0) = 0.000000; -NODES[1957](VELOCITY_Z,0) = 0.000000; -NODES[1962](VELOCITY_X,0) = 0.000000; -NODES[1962](VELOCITY_Y,0) = 0.000000; -NODES[1962](VELOCITY_Z,0) = 0.000000; -NODES[1963](VELOCITY_X,0) = 0.000000; -NODES[1963](VELOCITY_Y,0) = 0.000000; -NODES[1963](VELOCITY_Z,0) = 0.000000; -NODES[1965](VELOCITY_X,0) = 0.000000; -NODES[1965](VELOCITY_Y,0) = 0.000000; -NODES[1965](VELOCITY_Z,0) = 0.000000; -NODES[1968](VELOCITY_X,0) = 0.000000; -NODES[1968](VELOCITY_Y,0) = 0.000000; -NODES[1968](VELOCITY_Z,0) = 0.000000; -NODES[1970](VELOCITY_X,0) = 0.000000; -NODES[1970](VELOCITY_Y,0) = 0.000000; -NODES[1970](VELOCITY_Z,0) = 0.000000; -NODES[1971](VELOCITY_X,0) = 0.000000; -NODES[1971](VELOCITY_Y,0) = 0.000000; -NODES[1971](VELOCITY_Z,0) = 0.000000; -NODES[1974](VELOCITY_X,0) = 0.000000; -NODES[1974](VELOCITY_Y,0) = 0.000000; -NODES[1974](VELOCITY_Z,0) = 0.000000; -NODES[1979](VELOCITY_X,0) = 0.000000; -NODES[1979](VELOCITY_Y,0) = 0.000000; -NODES[1979](VELOCITY_Z,0) = 0.000000; -NODES[1980](VELOCITY_X,0) = 0.000000; -NODES[1980](VELOCITY_Y,0) = 0.000000; -NODES[1980](VELOCITY_Z,0) = 0.000000; -NODES[1981](VELOCITY_X,0) = 0.000000; -NODES[1981](VELOCITY_Y,0) = 0.000000; -NODES[1981](VELOCITY_Z,0) = 0.000000; -NODES[1982](VELOCITY_X,0) = 0.000000; -NODES[1982](VELOCITY_Y,0) = 0.000000; -NODES[1982](VELOCITY_Z,0) = 0.000000; -NODES[1983](VELOCITY_X,0) = 0.000000; -NODES[1983](VELOCITY_Y,0) = 0.000000; -NODES[1983](VELOCITY_Z,0) = 0.000000; -NODES[1984](VELOCITY_X,0) = 0.000000; -NODES[1984](VELOCITY_Y,0) = 0.000000; -NODES[1984](VELOCITY_Z,0) = 0.000000; -NODES[1986](VELOCITY_X,0) = 0.000000; -NODES[1986](VELOCITY_Y,0) = 0.000000; -NODES[1986](VELOCITY_Z,0) = 0.000000; -NODES[1988](VELOCITY_X,0) = 0.000000; -NODES[1988](VELOCITY_Y,0) = 0.000000; -NODES[1988](VELOCITY_Z,0) = 0.000000; -NODES[1990](VELOCITY_X,0) = 0.000000; -NODES[1990](VELOCITY_Y,0) = 0.000000; -NODES[1990](VELOCITY_Z,0) = 0.000000; -NODES[1991](VELOCITY_X,0) = 0.000000; -NODES[1991](VELOCITY_Y,0) = 0.000000; -NODES[1991](VELOCITY_Z,0) = 0.000000; -NODES[1993](VELOCITY_X,0) = 0.000000; -NODES[1993](VELOCITY_Y,0) = 0.000000; -NODES[1993](VELOCITY_Z,0) = 0.000000; -NODES[1994](VELOCITY_X,0) = 0.000000; -NODES[1994](VELOCITY_Y,0) = 0.000000; -NODES[1994](VELOCITY_Z,0) = 0.000000; -NODES[1996](VELOCITY_X,0) = 0.000000; -NODES[1996](VELOCITY_Y,0) = 0.000000; -NODES[1996](VELOCITY_Z,0) = 0.000000; -NODES[1998](VELOCITY_X,0) = 0.000000; -NODES[1998](VELOCITY_Y,0) = 0.000000; -NODES[1998](VELOCITY_Z,0) = 0.000000; -NODES[2000](VELOCITY_X,0) = 0.000000; -NODES[2000](VELOCITY_Y,0) = 0.000000; -NODES[2000](VELOCITY_Z,0) = 0.000000; -NODES[2003](VELOCITY_X,0) = 0.000000; -NODES[2003](VELOCITY_Y,0) = 0.000000; -NODES[2003](VELOCITY_Z,0) = 0.000000; -NODES[2004](VELOCITY_X,0) = 0.000000; -NODES[2004](VELOCITY_Y,0) = 0.000000; -NODES[2004](VELOCITY_Z,0) = 0.000000; -NODES[2005](VELOCITY_X,0) = 0.000000; -NODES[2005](VELOCITY_Y,0) = 0.000000; -NODES[2005](VELOCITY_Z,0) = 0.000000; -NODES[2011](VELOCITY_X,0) = 0.000000; -NODES[2011](VELOCITY_Y,0) = 0.000000; -NODES[2011](VELOCITY_Z,0) = 0.000000; -NODES[2014](VELOCITY_X,0) = 0.000000; -NODES[2014](VELOCITY_Y,0) = 0.000000; -NODES[2014](VELOCITY_Z,0) = 0.000000; -NODES[2015](VELOCITY_X,0) = 0.000000; -NODES[2015](VELOCITY_Y,0) = 0.000000; -NODES[2015](VELOCITY_Z,0) = 0.000000; -NODES[2016](VELOCITY_X,0) = 0.000000; -NODES[2016](VELOCITY_Y,0) = 0.000000; -NODES[2016](VELOCITY_Z,0) = 0.000000; -NODES[2017](VELOCITY_X,0) = 0.000000; -NODES[2017](VELOCITY_Y,0) = 0.000000; -NODES[2017](VELOCITY_Z,0) = 0.000000; -NODES[2020](VELOCITY_X,0) = 0.000000; -NODES[2020](VELOCITY_Y,0) = 0.000000; -NODES[2020](VELOCITY_Z,0) = 0.000000; -NODES[2023](VELOCITY_X,0) = 0.000000; -NODES[2023](VELOCITY_Y,0) = 0.000000; -NODES[2023](VELOCITY_Z,0) = 0.000000; -NODES[2024](VELOCITY_X,0) = 0.000000; -NODES[2024](VELOCITY_Y,0) = 0.000000; -NODES[2024](VELOCITY_Z,0) = 0.000000; -NODES[2029](VELOCITY_X,0) = 0.000000; -NODES[2029](VELOCITY_Y,0) = 0.000000; -NODES[2029](VELOCITY_Z,0) = 0.000000; -NODES[2031](VELOCITY_X,0) = 0.000000; -NODES[2031](VELOCITY_Y,0) = 0.000000; -NODES[2031](VELOCITY_Z,0) = 0.000000; -NODES[2035](VELOCITY_X,0) = 0.000000; -NODES[2035](VELOCITY_Y,0) = 0.000000; -NODES[2035](VELOCITY_Z,0) = 0.000000; -NODES[2036](VELOCITY_X,0) = 0.000000; -NODES[2036](VELOCITY_Y,0) = 0.000000; -NODES[2036](VELOCITY_Z,0) = 0.000000; -NODES[2039](VELOCITY_X,0) = 0.000000; -NODES[2039](VELOCITY_Y,0) = 0.000000; -NODES[2039](VELOCITY_Z,0) = 0.000000; -NODES[2040](VELOCITY_X,0) = 0.000000; -NODES[2040](VELOCITY_Y,0) = 0.000000; -NODES[2040](VELOCITY_Z,0) = 0.000000; -NODES[2042](VELOCITY_X,0) = 0.000000; -NODES[2042](VELOCITY_Y,0) = 0.000000; -NODES[2042](VELOCITY_Z,0) = 0.000000; -NODES[2044](VELOCITY_X,0) = 0.000000; -NODES[2044](VELOCITY_Y,0) = 0.000000; -NODES[2044](VELOCITY_Z,0) = 0.000000; -NODES[2048](VELOCITY_X,0) = 0.000000; -NODES[2048](VELOCITY_Y,0) = 0.000000; -NODES[2048](VELOCITY_Z,0) = 0.000000; -NODES[2049](VELOCITY_X,0) = 0.000000; -NODES[2049](VELOCITY_Y,0) = 0.000000; -NODES[2049](VELOCITY_Z,0) = 0.000000; -NODES[2050](VELOCITY_X,0) = 0.000000; -NODES[2050](VELOCITY_Y,0) = 0.000000; -NODES[2050](VELOCITY_Z,0) = 0.000000; -NODES[2053](VELOCITY_X,0) = 0.000000; -NODES[2053](VELOCITY_Y,0) = 0.000000; -NODES[2053](VELOCITY_Z,0) = 0.000000; -NODES[2055](VELOCITY_X,0) = 0.000000; -NODES[2055](VELOCITY_Y,0) = 0.000000; -NODES[2055](VELOCITY_Z,0) = 0.000000; -NODES[2059](VELOCITY_X,0) = 0.000000; -NODES[2059](VELOCITY_Y,0) = 0.000000; -NODES[2059](VELOCITY_Z,0) = 0.000000; -NODES[2063](VELOCITY_X,0) = 0.000000; -NODES[2063](VELOCITY_Y,0) = 0.000000; -NODES[2063](VELOCITY_Z,0) = 0.000000; -NODES[2067](VELOCITY_X,0) = 0.000000; -NODES[2067](VELOCITY_Y,0) = 0.000000; -NODES[2067](VELOCITY_Z,0) = 0.000000; -NODES[2068](VELOCITY_X,0) = 0.000000; -NODES[2068](VELOCITY_Y,0) = 0.000000; -NODES[2068](VELOCITY_Z,0) = 0.000000; -NODES[2069](VELOCITY_X,0) = 0.000000; -NODES[2069](VELOCITY_Y,0) = 0.000000; -NODES[2069](VELOCITY_Z,0) = 0.000000; -NODES[2070](VELOCITY_X,0) = 0.000000; -NODES[2070](VELOCITY_Y,0) = 0.000000; -NODES[2070](VELOCITY_Z,0) = 0.000000; -NODES[2073](VELOCITY_X,0) = 0.000000; -NODES[2073](VELOCITY_Y,0) = 0.000000; -NODES[2073](VELOCITY_Z,0) = 0.000000; -NODES[2077](VELOCITY_X,0) = 0.000000; -NODES[2077](VELOCITY_Y,0) = 0.000000; -NODES[2077](VELOCITY_Z,0) = 0.000000; -NODES[2082](VELOCITY_X,0) = 0.000000; -NODES[2082](VELOCITY_Y,0) = 0.000000; -NODES[2082](VELOCITY_Z,0) = 0.000000; -NODES[2084](VELOCITY_X,0) = 0.000000; -NODES[2084](VELOCITY_Y,0) = 0.000000; -NODES[2084](VELOCITY_Z,0) = 0.000000; -NODES[2085](VELOCITY_X,0) = 0.000000; -NODES[2085](VELOCITY_Y,0) = 0.000000; -NODES[2085](VELOCITY_Z,0) = 0.000000; -NODES[2088](VELOCITY_X,0) = 0.000000; -NODES[2088](VELOCITY_Y,0) = 0.000000; -NODES[2088](VELOCITY_Z,0) = 0.000000; -NODES[2089](VELOCITY_X,0) = 0.000000; -NODES[2089](VELOCITY_Y,0) = 0.000000; -NODES[2089](VELOCITY_Z,0) = 0.000000; -NODES[2090](VELOCITY_X,0) = 0.000000; -NODES[2090](VELOCITY_Y,0) = 0.000000; -NODES[2090](VELOCITY_Z,0) = 0.000000; -NODES[2091](VELOCITY_X,0) = 0.000000; -NODES[2091](VELOCITY_Y,0) = 0.000000; -NODES[2091](VELOCITY_Z,0) = 0.000000; -NODES[2093](VELOCITY_X,0) = 0.000000; -NODES[2093](VELOCITY_Y,0) = 0.000000; -NODES[2093](VELOCITY_Z,0) = 0.000000; -NODES[2095](VELOCITY_X,0) = 0.000000; -NODES[2095](VELOCITY_Y,0) = 0.000000; -NODES[2095](VELOCITY_Z,0) = 0.000000; -NODES[2097](VELOCITY_X,0) = 0.000000; -NODES[2097](VELOCITY_Y,0) = 0.000000; -NODES[2097](VELOCITY_Z,0) = 0.000000; -NODES[2100](VELOCITY_X,0) = 0.000000; -NODES[2100](VELOCITY_Y,0) = 0.000000; -NODES[2100](VELOCITY_Z,0) = 0.000000; -NODES[2101](VELOCITY_X,0) = 0.000000; -NODES[2101](VELOCITY_Y,0) = 0.000000; -NODES[2101](VELOCITY_Z,0) = 0.000000; -NODES[2102](VELOCITY_X,0) = 0.000000; -NODES[2102](VELOCITY_Y,0) = 0.000000; -NODES[2102](VELOCITY_Z,0) = 0.000000; -NODES[2103](VELOCITY_X,0) = 0.000000; -NODES[2103](VELOCITY_Y,0) = 0.000000; -NODES[2103](VELOCITY_Z,0) = 0.000000; -NODES[2104](VELOCITY_X,0) = 0.000000; -NODES[2104](VELOCITY_Y,0) = 0.000000; -NODES[2104](VELOCITY_Z,0) = 0.000000; -NODES[2105](VELOCITY_X,0) = 0.000000; -NODES[2105](VELOCITY_Y,0) = 0.000000; -NODES[2105](VELOCITY_Z,0) = 0.000000; -NODES[2107](VELOCITY_X,0) = 0.000000; -NODES[2107](VELOCITY_Y,0) = 0.000000; -NODES[2107](VELOCITY_Z,0) = 0.000000; -NODES[2110](VELOCITY_X,0) = 0.000000; -NODES[2110](VELOCITY_Y,0) = 0.000000; -NODES[2110](VELOCITY_Z,0) = 0.000000; -NODES[2111](VELOCITY_X,0) = 0.000000; -NODES[2111](VELOCITY_Y,0) = 0.000000; -NODES[2111](VELOCITY_Z,0) = 0.000000; -NODES[2112](VELOCITY_X,0) = 0.000000; -NODES[2112](VELOCITY_Y,0) = 0.000000; -NODES[2112](VELOCITY_Z,0) = 0.000000; -NODES[2113](VELOCITY_X,0) = 0.000000; -NODES[2113](VELOCITY_Y,0) = 0.000000; -NODES[2113](VELOCITY_Z,0) = 0.000000; -NODES[2115](VELOCITY_X,0) = 0.000000; -NODES[2115](VELOCITY_Y,0) = 0.000000; -NODES[2115](VELOCITY_Z,0) = 0.000000; -NODES[2117](VELOCITY_X,0) = 0.000000; -NODES[2117](VELOCITY_Y,0) = 0.000000; -NODES[2117](VELOCITY_Z,0) = 0.000000; -NODES[2119](VELOCITY_X,0) = 0.000000; -NODES[2119](VELOCITY_Y,0) = 0.000000; -NODES[2119](VELOCITY_Z,0) = 0.000000; -NODES[2120](VELOCITY_X,0) = 0.000000; -NODES[2120](VELOCITY_Y,0) = 0.000000; -NODES[2120](VELOCITY_Z,0) = 0.000000; -NODES[2121](VELOCITY_X,0) = 0.000000; -NODES[2121](VELOCITY_Y,0) = 0.000000; -NODES[2121](VELOCITY_Z,0) = 0.000000; -NODES[2125](VELOCITY_X,0) = 0.000000; -NODES[2125](VELOCITY_Y,0) = 0.000000; -NODES[2125](VELOCITY_Z,0) = 0.000000; -NODES[2127](VELOCITY_X,0) = 0.000000; -NODES[2127](VELOCITY_Y,0) = 0.000000; -NODES[2127](VELOCITY_Z,0) = 0.000000; -NODES[2128](VELOCITY_X,0) = 0.000000; -NODES[2128](VELOCITY_Y,0) = 0.000000; -NODES[2128](VELOCITY_Z,0) = 0.000000; -NODES[2129](VELOCITY_X,0) = 0.000000; -NODES[2129](VELOCITY_Y,0) = 0.000000; -NODES[2129](VELOCITY_Z,0) = 0.000000; -NODES[2131](VELOCITY_X,0) = 0.000000; -NODES[2131](VELOCITY_Y,0) = 0.000000; -NODES[2131](VELOCITY_Z,0) = 0.000000; -NODES[2133](VELOCITY_X,0) = 0.000000; -NODES[2133](VELOCITY_Y,0) = 0.000000; -NODES[2133](VELOCITY_Z,0) = 0.000000; -NODES[2136](VELOCITY_X,0) = 0.000000; -NODES[2136](VELOCITY_Y,0) = 0.000000; -NODES[2136](VELOCITY_Z,0) = 0.000000; -NODES[2138](VELOCITY_X,0) = 0.000000; -NODES[2138](VELOCITY_Y,0) = 0.000000; -NODES[2138](VELOCITY_Z,0) = 0.000000; -NODES[2139](VELOCITY_X,0) = 0.000000; -NODES[2139](VELOCITY_Y,0) = 0.000000; -NODES[2139](VELOCITY_Z,0) = 0.000000; -NODES[2140](VELOCITY_X,0) = 0.000000; -NODES[2140](VELOCITY_Y,0) = 0.000000; -NODES[2140](VELOCITY_Z,0) = 0.000000; -NODES[2145](VELOCITY_X,0) = 0.000000; -NODES[2145](VELOCITY_Y,0) = 0.000000; -NODES[2145](VELOCITY_Z,0) = 0.000000; -NODES[2148](VELOCITY_X,0) = 0.000000; -NODES[2148](VELOCITY_Y,0) = 0.000000; -NODES[2148](VELOCITY_Z,0) = 0.000000; -NODES[2149](VELOCITY_X,0) = 0.000000; -NODES[2149](VELOCITY_Y,0) = 0.000000; -NODES[2149](VELOCITY_Z,0) = 0.000000; -NODES[2150](VELOCITY_X,0) = 0.000000; -NODES[2150](VELOCITY_Y,0) = 0.000000; -NODES[2150](VELOCITY_Z,0) = 0.000000; -NODES[2153](VELOCITY_X,0) = 0.000000; -NODES[2153](VELOCITY_Y,0) = 0.000000; -NODES[2153](VELOCITY_Z,0) = 0.000000; -NODES[2155](VELOCITY_X,0) = 0.000000; -NODES[2155](VELOCITY_Y,0) = 0.000000; -NODES[2155](VELOCITY_Z,0) = 0.000000; -NODES[2158](VELOCITY_X,0) = 0.000000; -NODES[2158](VELOCITY_Y,0) = 0.000000; -NODES[2158](VELOCITY_Z,0) = 0.000000; -NODES[2159](VELOCITY_X,0) = 0.000000; -NODES[2159](VELOCITY_Y,0) = 0.000000; -NODES[2159](VELOCITY_Z,0) = 0.000000; -NODES[2161](VELOCITY_X,0) = 0.000000; -NODES[2161](VELOCITY_Y,0) = 0.000000; -NODES[2161](VELOCITY_Z,0) = 0.000000; -NODES[2164](VELOCITY_X,0) = 0.000000; -NODES[2164](VELOCITY_Y,0) = 0.000000; -NODES[2164](VELOCITY_Z,0) = 0.000000; -NODES[2165](VELOCITY_X,0) = 0.000000; -NODES[2165](VELOCITY_Y,0) = 0.000000; -NODES[2165](VELOCITY_Z,0) = 0.000000; -NODES[2168](VELOCITY_X,0) = 0.000000; -NODES[2168](VELOCITY_Y,0) = 0.000000; -NODES[2168](VELOCITY_Z,0) = 0.000000; -NODES[2169](VELOCITY_X,0) = 0.000000; -NODES[2169](VELOCITY_Y,0) = 0.000000; -NODES[2169](VELOCITY_Z,0) = 0.000000; -NODES[2172](VELOCITY_X,0) = 0.000000; -NODES[2172](VELOCITY_Y,0) = 0.000000; -NODES[2172](VELOCITY_Z,0) = 0.000000; -NODES[2176](VELOCITY_X,0) = 0.000000; -NODES[2176](VELOCITY_Y,0) = 0.000000; -NODES[2176](VELOCITY_Z,0) = 0.000000; -NODES[2177](VELOCITY_X,0) = 0.000000; -NODES[2177](VELOCITY_Y,0) = 0.000000; -NODES[2177](VELOCITY_Z,0) = 0.000000; -NODES[2180](VELOCITY_X,0) = 0.000000; -NODES[2180](VELOCITY_Y,0) = 0.000000; -NODES[2180](VELOCITY_Z,0) = 0.000000; -NODES[2181](VELOCITY_X,0) = 0.000000; -NODES[2181](VELOCITY_Y,0) = 0.000000; -NODES[2181](VELOCITY_Z,0) = 0.000000; -NODES[2183](VELOCITY_X,0) = 0.000000; -NODES[2183](VELOCITY_Y,0) = 0.000000; -NODES[2183](VELOCITY_Z,0) = 0.000000; -NODES[2184](VELOCITY_X,0) = 0.000000; -NODES[2184](VELOCITY_Y,0) = 0.000000; -NODES[2184](VELOCITY_Z,0) = 0.000000; -NODES[2189](VELOCITY_X,0) = 0.000000; -NODES[2189](VELOCITY_Y,0) = 0.000000; -NODES[2189](VELOCITY_Z,0) = 0.000000; -NODES[2190](VELOCITY_X,0) = 0.000000; -NODES[2190](VELOCITY_Y,0) = 0.000000; -NODES[2190](VELOCITY_Z,0) = 0.000000; -NODES[2191](VELOCITY_X,0) = 0.000000; -NODES[2191](VELOCITY_Y,0) = 0.000000; -NODES[2191](VELOCITY_Z,0) = 0.000000; -NODES[2192](VELOCITY_X,0) = 0.000000; -NODES[2192](VELOCITY_Y,0) = 0.000000; -NODES[2192](VELOCITY_Z,0) = 0.000000; -NODES[2195](VELOCITY_X,0) = 0.000000; -NODES[2195](VELOCITY_Y,0) = 0.000000; -NODES[2195](VELOCITY_Z,0) = 0.000000; -NODES[2202](VELOCITY_X,0) = 0.000000; -NODES[2202](VELOCITY_Y,0) = 0.000000; -NODES[2202](VELOCITY_Z,0) = 0.000000; -NODES[2205](VELOCITY_X,0) = 0.000000; -NODES[2205](VELOCITY_Y,0) = 0.000000; -NODES[2205](VELOCITY_Z,0) = 0.000000; -NODES[2208](VELOCITY_X,0) = 0.000000; -NODES[2208](VELOCITY_Y,0) = 0.000000; -NODES[2208](VELOCITY_Z,0) = 0.000000; -NODES[2209](VELOCITY_X,0) = 0.000000; -NODES[2209](VELOCITY_Y,0) = 0.000000; -NODES[2209](VELOCITY_Z,0) = 0.000000; -NODES[2216](VELOCITY_X,0) = 0.000000; -NODES[2216](VELOCITY_Y,0) = 0.000000; -NODES[2216](VELOCITY_Z,0) = 0.000000; -NODES[2217](VELOCITY_X,0) = 0.000000; -NODES[2217](VELOCITY_Y,0) = 0.000000; -NODES[2217](VELOCITY_Z,0) = 0.000000; -NODES[2218](VELOCITY_X,0) = 0.000000; -NODES[2218](VELOCITY_Y,0) = 0.000000; -NODES[2218](VELOCITY_Z,0) = 0.000000; -NODES[2225](VELOCITY_X,0) = 0.000000; -NODES[2225](VELOCITY_Y,0) = 0.000000; -NODES[2225](VELOCITY_Z,0) = 0.000000; -NODES[2227](VELOCITY_X,0) = 0.000000; -NODES[2227](VELOCITY_Y,0) = 0.000000; -NODES[2227](VELOCITY_Z,0) = 0.000000; -NODES[2230](VELOCITY_X,0) = 0.000000; -NODES[2230](VELOCITY_Y,0) = 0.000000; -NODES[2230](VELOCITY_Z,0) = 0.000000; -NODES[2231](VELOCITY_X,0) = 0.000000; -NODES[2231](VELOCITY_Y,0) = 0.000000; -NODES[2231](VELOCITY_Z,0) = 0.000000; -NODES[2236](VELOCITY_X,0) = 0.000000; -NODES[2236](VELOCITY_Y,0) = 0.000000; -NODES[2236](VELOCITY_Z,0) = 0.000000; -NODES[2238](VELOCITY_X,0) = 0.000000; -NODES[2238](VELOCITY_Y,0) = 0.000000; -NODES[2238](VELOCITY_Z,0) = 0.000000; -NODES[2242](VELOCITY_X,0) = 0.000000; -NODES[2242](VELOCITY_Y,0) = 0.000000; -NODES[2242](VELOCITY_Z,0) = 0.000000; -NODES[2244](VELOCITY_X,0) = 0.000000; -NODES[2244](VELOCITY_Y,0) = 0.000000; -NODES[2244](VELOCITY_Z,0) = 0.000000; -NODES[2246](VELOCITY_X,0) = 0.000000; -NODES[2246](VELOCITY_Y,0) = 0.000000; -NODES[2246](VELOCITY_Z,0) = 0.000000; -NODES[2247](VELOCITY_X,0) = 0.000000; -NODES[2247](VELOCITY_Y,0) = 0.000000; -NODES[2247](VELOCITY_Z,0) = 0.000000; -NODES[2251](VELOCITY_X,0) = 0.000000; -NODES[2251](VELOCITY_Y,0) = 0.000000; -NODES[2251](VELOCITY_Z,0) = 0.000000; -NODES[2255](VELOCITY_X,0) = 0.000000; -NODES[2255](VELOCITY_Y,0) = 0.000000; -NODES[2255](VELOCITY_Z,0) = 0.000000; -NODES[2265](VELOCITY_X,0) = 0.000000; -NODES[2265](VELOCITY_Y,0) = 0.000000; -NODES[2265](VELOCITY_Z,0) = 0.000000; -NODES[2268](VELOCITY_X,0) = 0.000000; -NODES[2268](VELOCITY_Y,0) = 0.000000; -NODES[2268](VELOCITY_Z,0) = 0.000000; -NODES[2274](VELOCITY_X,0) = 0.000000; -NODES[2274](VELOCITY_Y,0) = 0.000000; -NODES[2274](VELOCITY_Z,0) = 0.000000; -NODES[2277](VELOCITY_X,0) = 0.000000; -NODES[2277](VELOCITY_Y,0) = 0.000000; -NODES[2277](VELOCITY_Z,0) = 0.000000; -NODES[2278](VELOCITY_X,0) = 0.000000; -NODES[2278](VELOCITY_Y,0) = 0.000000; -NODES[2278](VELOCITY_Z,0) = 0.000000; -NODES[2284](VELOCITY_X,0) = 0.000000; -NODES[2284](VELOCITY_Y,0) = 0.000000; -NODES[2284](VELOCITY_Z,0) = 0.000000; -NODES[2285](VELOCITY_X,0) = 0.000000; -NODES[2285](VELOCITY_Y,0) = 0.000000; -NODES[2285](VELOCITY_Z,0) = 0.000000; -NODES[2286](VELOCITY_X,0) = 0.000000; -NODES[2286](VELOCITY_Y,0) = 0.000000; -NODES[2286](VELOCITY_Z,0) = 0.000000; -NODES[2293](VELOCITY_X,0) = 0.000000; -NODES[2293](VELOCITY_Y,0) = 0.000000; -NODES[2293](VELOCITY_Z,0) = 0.000000; -NODES[2295](VELOCITY_X,0) = 0.000000; -NODES[2295](VELOCITY_Y,0) = 0.000000; -NODES[2295](VELOCITY_Z,0) = 0.000000; -NODES[2297](VELOCITY_X,0) = 0.000000; -NODES[2297](VELOCITY_Y,0) = 0.000000; -NODES[2297](VELOCITY_Z,0) = 0.000000; -NODES[2299](VELOCITY_X,0) = 0.000000; -NODES[2299](VELOCITY_Y,0) = 0.000000; -NODES[2299](VELOCITY_Z,0) = 0.000000; -NODES[2302](VELOCITY_X,0) = 0.000000; -NODES[2302](VELOCITY_Y,0) = 0.000000; -NODES[2302](VELOCITY_Z,0) = 0.000000; -NODES[2303](VELOCITY_X,0) = 0.000000; -NODES[2303](VELOCITY_Y,0) = 0.000000; -NODES[2303](VELOCITY_Z,0) = 0.000000; -NODES[2304](VELOCITY_X,0) = 0.000000; -NODES[2304](VELOCITY_Y,0) = 0.000000; -NODES[2304](VELOCITY_Z,0) = 0.000000; -NODES[2305](VELOCITY_X,0) = 0.000000; -NODES[2305](VELOCITY_Y,0) = 0.000000; -NODES[2305](VELOCITY_Z,0) = 0.000000; -NODES[2306](VELOCITY_X,0) = 0.000000; -NODES[2306](VELOCITY_Y,0) = 0.000000; -NODES[2306](VELOCITY_Z,0) = 0.000000; -NODES[2307](VELOCITY_X,0) = 0.000000; -NODES[2307](VELOCITY_Y,0) = 0.000000; -NODES[2307](VELOCITY_Z,0) = 0.000000; -NODES[2308](VELOCITY_X,0) = 0.000000; -NODES[2308](VELOCITY_Y,0) = 0.000000; -NODES[2308](VELOCITY_Z,0) = 0.000000; -NODES[2309](VELOCITY_X,0) = 0.000000; -NODES[2309](VELOCITY_Y,0) = 0.000000; -NODES[2309](VELOCITY_Z,0) = 0.000000; -NODES[2315](VELOCITY_X,0) = 0.000000; -NODES[2315](VELOCITY_Y,0) = 0.000000; -NODES[2315](VELOCITY_Z,0) = 0.000000; -NODES[2316](VELOCITY_X,0) = 0.000000; -NODES[2316](VELOCITY_Y,0) = 0.000000; -NODES[2316](VELOCITY_Z,0) = 0.000000; -NODES[2321](VELOCITY_X,0) = 0.000000; -NODES[2321](VELOCITY_Y,0) = 0.000000; -NODES[2321](VELOCITY_Z,0) = 0.000000; -NODES[2323](VELOCITY_X,0) = 0.000000; -NODES[2323](VELOCITY_Y,0) = 0.000000; -NODES[2323](VELOCITY_Z,0) = 0.000000; -NODES[2324](VELOCITY_X,0) = 0.000000; -NODES[2324](VELOCITY_Y,0) = 0.000000; -NODES[2324](VELOCITY_Z,0) = 0.000000; -NODES[2325](VELOCITY_X,0) = 0.000000; -NODES[2325](VELOCITY_Y,0) = 0.000000; -NODES[2325](VELOCITY_Z,0) = 0.000000; -NODES[2328](VELOCITY_X,0) = 0.000000; -NODES[2328](VELOCITY_Y,0) = 0.000000; -NODES[2328](VELOCITY_Z,0) = 0.000000; -NODES[2329](VELOCITY_X,0) = 0.000000; -NODES[2329](VELOCITY_Y,0) = 0.000000; -NODES[2329](VELOCITY_Z,0) = 0.000000; -NODES[2330](VELOCITY_X,0) = 0.000000; -NODES[2330](VELOCITY_Y,0) = 0.000000; -NODES[2330](VELOCITY_Z,0) = 0.000000; -NODES[2331](VELOCITY_X,0) = 0.000000; -NODES[2331](VELOCITY_Y,0) = 0.000000; -NODES[2331](VELOCITY_Z,0) = 0.000000; -NODES[2332](VELOCITY_X,0) = 0.000000; -NODES[2332](VELOCITY_Y,0) = 0.000000; -NODES[2332](VELOCITY_Z,0) = 0.000000; -NODES[2333](VELOCITY_X,0) = 0.000000; -NODES[2333](VELOCITY_Y,0) = 0.000000; -NODES[2333](VELOCITY_Z,0) = 0.000000; -NODES[2335](VELOCITY_X,0) = 0.000000; -NODES[2335](VELOCITY_Y,0) = 0.000000; -NODES[2335](VELOCITY_Z,0) = 0.000000; -NODES[2336](VELOCITY_X,0) = 0.000000; -NODES[2336](VELOCITY_Y,0) = 0.000000; -NODES[2336](VELOCITY_Z,0) = 0.000000; -NODES[2345](VELOCITY_X,0) = 0.000000; -NODES[2345](VELOCITY_Y,0) = 0.000000; -NODES[2345](VELOCITY_Z,0) = 0.000000; -NODES[2347](VELOCITY_X,0) = 0.000000; -NODES[2347](VELOCITY_Y,0) = 0.000000; -NODES[2347](VELOCITY_Z,0) = 0.000000; -NODES[2348](VELOCITY_X,0) = 0.000000; -NODES[2348](VELOCITY_Y,0) = 0.000000; -NODES[2348](VELOCITY_Z,0) = 0.000000; -NODES[2351](VELOCITY_X,0) = 0.000000; -NODES[2351](VELOCITY_Y,0) = 0.000000; -NODES[2351](VELOCITY_Z,0) = 0.000000; -NODES[2356](VELOCITY_X,0) = 0.000000; -NODES[2356](VELOCITY_Y,0) = 0.000000; -NODES[2356](VELOCITY_Z,0) = 0.000000; -NODES[2358](VELOCITY_X,0) = 0.000000; -NODES[2358](VELOCITY_Y,0) = 0.000000; -NODES[2358](VELOCITY_Z,0) = 0.000000; -NODES[2359](VELOCITY_X,0) = 0.000000; -NODES[2359](VELOCITY_Y,0) = 0.000000; -NODES[2359](VELOCITY_Z,0) = 0.000000; -NODES[2360](VELOCITY_X,0) = 0.000000; -NODES[2360](VELOCITY_Y,0) = 0.000000; -NODES[2360](VELOCITY_Z,0) = 0.000000; -NODES[2361](VELOCITY_X,0) = 0.000000; -NODES[2361](VELOCITY_Y,0) = 0.000000; -NODES[2361](VELOCITY_Z,0) = 0.000000; -NODES[2362](VELOCITY_X,0) = 0.000000; -NODES[2362](VELOCITY_Y,0) = 0.000000; -NODES[2362](VELOCITY_Z,0) = 0.000000; -NODES[2363](VELOCITY_X,0) = 0.000000; -NODES[2363](VELOCITY_Y,0) = 0.000000; -NODES[2363](VELOCITY_Z,0) = 0.000000; -NODES[2369](VELOCITY_X,0) = 0.000000; -NODES[2369](VELOCITY_Y,0) = 0.000000; -NODES[2369](VELOCITY_Z,0) = 0.000000; -NODES[2370](VELOCITY_X,0) = 0.000000; -NODES[2370](VELOCITY_Y,0) = 0.000000; -NODES[2370](VELOCITY_Z,0) = 0.000000; -NODES[2371](VELOCITY_X,0) = 0.000000; -NODES[2371](VELOCITY_Y,0) = 0.000000; -NODES[2371](VELOCITY_Z,0) = 0.000000; -NODES[2375](VELOCITY_X,0) = 0.000000; -NODES[2375](VELOCITY_Y,0) = 0.000000; -NODES[2375](VELOCITY_Z,0) = 0.000000; -NODES[2376](VELOCITY_X,0) = 0.000000; -NODES[2376](VELOCITY_Y,0) = 0.000000; -NODES[2376](VELOCITY_Z,0) = 0.000000; -NODES[2377](VELOCITY_X,0) = 0.000000; -NODES[2377](VELOCITY_Y,0) = 0.000000; -NODES[2377](VELOCITY_Z,0) = 0.000000; -NODES[2382](VELOCITY_X,0) = 0.000000; -NODES[2382](VELOCITY_Y,0) = 0.000000; -NODES[2382](VELOCITY_Z,0) = 0.000000; -NODES[2388](VELOCITY_X,0) = 0.000000; -NODES[2388](VELOCITY_Y,0) = 0.000000; -NODES[2388](VELOCITY_Z,0) = 0.000000; -NODES[2392](VELOCITY_X,0) = 0.000000; -NODES[2392](VELOCITY_Y,0) = 0.000000; -NODES[2392](VELOCITY_Z,0) = 0.000000; -NODES[2393](VELOCITY_X,0) = 0.000000; -NODES[2393](VELOCITY_Y,0) = 0.000000; -NODES[2393](VELOCITY_Z,0) = 0.000000; -NODES[2395](VELOCITY_X,0) = 0.000000; -NODES[2395](VELOCITY_Y,0) = 0.000000; -NODES[2395](VELOCITY_Z,0) = 0.000000; -NODES[2397](VELOCITY_X,0) = 0.000000; -NODES[2397](VELOCITY_Y,0) = 0.000000; -NODES[2397](VELOCITY_Z,0) = 0.000000; -NODES[2399](VELOCITY_X,0) = 0.000000; -NODES[2399](VELOCITY_Y,0) = 0.000000; -NODES[2399](VELOCITY_Z,0) = 0.000000; -NODES[2405](VELOCITY_X,0) = 0.000000; -NODES[2405](VELOCITY_Y,0) = 0.000000; -NODES[2405](VELOCITY_Z,0) = 0.000000; -NODES[2411](VELOCITY_X,0) = 0.000000; -NODES[2411](VELOCITY_Y,0) = 0.000000; -NODES[2411](VELOCITY_Z,0) = 0.000000; -NODES[2412](VELOCITY_X,0) = 0.000000; -NODES[2412](VELOCITY_Y,0) = 0.000000; -NODES[2412](VELOCITY_Z,0) = 0.000000; -NODES[2418](VELOCITY_X,0) = 0.000000; -NODES[2418](VELOCITY_Y,0) = 0.000000; -NODES[2418](VELOCITY_Z,0) = 0.000000; -NODES[2424](VELOCITY_X,0) = 0.000000; -NODES[2424](VELOCITY_Y,0) = 0.000000; -NODES[2424](VELOCITY_Z,0) = 0.000000; -NODES[2428](VELOCITY_X,0) = 0.000000; -NODES[2428](VELOCITY_Y,0) = 0.000000; -NODES[2428](VELOCITY_Z,0) = 0.000000; -NODES[2429](VELOCITY_X,0) = 0.000000; -NODES[2429](VELOCITY_Y,0) = 0.000000; -NODES[2429](VELOCITY_Z,0) = 0.000000; -NODES[2430](VELOCITY_X,0) = 0.000000; -NODES[2430](VELOCITY_Y,0) = 0.000000; -NODES[2430](VELOCITY_Z,0) = 0.000000; -NODES[2434](VELOCITY_X,0) = 0.000000; -NODES[2434](VELOCITY_Y,0) = 0.000000; -NODES[2434](VELOCITY_Z,0) = 0.000000; -NODES[2435](VELOCITY_X,0) = 0.000000; -NODES[2435](VELOCITY_Y,0) = 0.000000; -NODES[2435](VELOCITY_Z,0) = 0.000000; -NODES[2443](VELOCITY_X,0) = 0.000000; -NODES[2443](VELOCITY_Y,0) = 0.000000; -NODES[2443](VELOCITY_Z,0) = 0.000000; -NODES[2446](VELOCITY_X,0) = 0.000000; -NODES[2446](VELOCITY_Y,0) = 0.000000; -NODES[2446](VELOCITY_Z,0) = 0.000000; -NODES[2452](VELOCITY_X,0) = 0.000000; -NODES[2452](VELOCITY_Y,0) = 0.000000; -NODES[2452](VELOCITY_Z,0) = 0.000000; -NODES[2457](VELOCITY_X,0) = 0.000000; -NODES[2457](VELOCITY_Y,0) = 0.000000; -NODES[2457](VELOCITY_Z,0) = 0.000000; -NODES[2458](VELOCITY_X,0) = 0.000000; -NODES[2458](VELOCITY_Y,0) = 0.000000; -NODES[2458](VELOCITY_Z,0) = 0.000000; -NODES[2459](VELOCITY_X,0) = 0.000000; -NODES[2459](VELOCITY_Y,0) = 0.000000; -NODES[2459](VELOCITY_Z,0) = 0.000000; -NODES[2461](VELOCITY_X,0) = 0.000000; -NODES[2461](VELOCITY_Y,0) = 0.000000; -NODES[2461](VELOCITY_Z,0) = 0.000000; -NODES[2462](VELOCITY_X,0) = 0.000000; -NODES[2462](VELOCITY_Y,0) = 0.000000; -NODES[2462](VELOCITY_Z,0) = 0.000000; -NODES[2470](VELOCITY_X,0) = 0.000000; -NODES[2470](VELOCITY_Y,0) = 0.000000; -NODES[2470](VELOCITY_Z,0) = 0.000000; -NODES[2472](VELOCITY_X,0) = 0.000000; -NODES[2472](VELOCITY_Y,0) = 0.000000; -NODES[2472](VELOCITY_Z,0) = 0.000000; -NODES[2473](VELOCITY_X,0) = 0.000000; -NODES[2473](VELOCITY_Y,0) = 0.000000; -NODES[2473](VELOCITY_Z,0) = 0.000000; -NODES[2478](VELOCITY_X,0) = 0.000000; -NODES[2478](VELOCITY_Y,0) = 0.000000; -NODES[2478](VELOCITY_Z,0) = 0.000000; -NODES[2479](VELOCITY_X,0) = 0.000000; -NODES[2479](VELOCITY_Y,0) = 0.000000; -NODES[2479](VELOCITY_Z,0) = 0.000000; -NODES[2488](VELOCITY_X,0) = 0.000000; -NODES[2488](VELOCITY_Y,0) = 0.000000; -NODES[2488](VELOCITY_Z,0) = 0.000000; -NODES[2489](VELOCITY_X,0) = 0.000000; -NODES[2489](VELOCITY_Y,0) = 0.000000; -NODES[2489](VELOCITY_Z,0) = 0.000000; -NODES[2492](VELOCITY_X,0) = 0.000000; -NODES[2492](VELOCITY_Y,0) = 0.000000; -NODES[2492](VELOCITY_Z,0) = 0.000000; -NODES[2499](VELOCITY_X,0) = 0.000000; -NODES[2499](VELOCITY_Y,0) = 0.000000; -NODES[2499](VELOCITY_Z,0) = 0.000000; -NODES[2505](VELOCITY_X,0) = 0.000000; -NODES[2505](VELOCITY_Y,0) = 0.000000; -NODES[2505](VELOCITY_Z,0) = 0.000000; -NODES[2506](VELOCITY_X,0) = 0.000000; -NODES[2506](VELOCITY_Y,0) = 0.000000; -NODES[2506](VELOCITY_Z,0) = 0.000000; -NODES[2508](VELOCITY_X,0) = 0.000000; -NODES[2508](VELOCITY_Y,0) = 0.000000; -NODES[2508](VELOCITY_Z,0) = 0.000000; -NODES[2510](VELOCITY_X,0) = 0.000000; -NODES[2510](VELOCITY_Y,0) = 0.000000; -NODES[2510](VELOCITY_Z,0) = 0.000000; -NODES[2513](VELOCITY_X,0) = 0.000000; -NODES[2513](VELOCITY_Y,0) = 0.000000; -NODES[2513](VELOCITY_Z,0) = 0.000000; -NODES[2515](VELOCITY_X,0) = 0.000000; -NODES[2515](VELOCITY_Y,0) = 0.000000; -NODES[2515](VELOCITY_Z,0) = 0.000000; -NODES[2519](VELOCITY_X,0) = 0.000000; -NODES[2519](VELOCITY_Y,0) = 0.000000; -NODES[2519](VELOCITY_Z,0) = 0.000000; -NODES[2521](VELOCITY_X,0) = 0.000000; -NODES[2521](VELOCITY_Y,0) = 0.000000; -NODES[2521](VELOCITY_Z,0) = 0.000000; -NODES[2525](VELOCITY_X,0) = 0.000000; -NODES[2525](VELOCITY_Y,0) = 0.000000; -NODES[2525](VELOCITY_Z,0) = 0.000000; -NODES[2526](VELOCITY_X,0) = 0.000000; -NODES[2526](VELOCITY_Y,0) = 0.000000; -NODES[2526](VELOCITY_Z,0) = 0.000000; -NODES[2530](VELOCITY_X,0) = 0.000000; -NODES[2530](VELOCITY_Y,0) = 0.000000; -NODES[2530](VELOCITY_Z,0) = 0.000000; -NODES[2533](VELOCITY_X,0) = 0.000000; -NODES[2533](VELOCITY_Y,0) = 0.000000; -NODES[2533](VELOCITY_Z,0) = 0.000000; -NODES[2540](VELOCITY_X,0) = 0.000000; -NODES[2540](VELOCITY_Y,0) = 0.000000; -NODES[2540](VELOCITY_Z,0) = 0.000000; -NODES[2543](VELOCITY_X,0) = 0.000000; -NODES[2543](VELOCITY_Y,0) = 0.000000; -NODES[2543](VELOCITY_Z,0) = 0.000000; -NODES[2545](VELOCITY_X,0) = 0.000000; -NODES[2545](VELOCITY_Y,0) = 0.000000; -NODES[2545](VELOCITY_Z,0) = 0.000000; -NODES[2549](VELOCITY_X,0) = 0.000000; -NODES[2549](VELOCITY_Y,0) = 0.000000; -NODES[2549](VELOCITY_Z,0) = 0.000000; -NODES[2551](VELOCITY_X,0) = 0.000000; -NODES[2551](VELOCITY_Y,0) = 0.000000; -NODES[2551](VELOCITY_Z,0) = 0.000000; -NODES[2552](VELOCITY_X,0) = 0.000000; -NODES[2552](VELOCITY_Y,0) = 0.000000; -NODES[2552](VELOCITY_Z,0) = 0.000000; -NODES[2554](VELOCITY_X,0) = 0.000000; -NODES[2554](VELOCITY_Y,0) = 0.000000; -NODES[2554](VELOCITY_Z,0) = 0.000000; -NODES[2559](VELOCITY_X,0) = 0.000000; -NODES[2559](VELOCITY_Y,0) = 0.000000; -NODES[2559](VELOCITY_Z,0) = 0.000000; -NODES[2560](VELOCITY_X,0) = 0.000000; -NODES[2560](VELOCITY_Y,0) = 0.000000; -NODES[2560](VELOCITY_Z,0) = 0.000000; -NODES[2571](VELOCITY_X,0) = 0.000000; -NODES[2571](VELOCITY_Y,0) = 0.000000; -NODES[2571](VELOCITY_Z,0) = 0.000000; -NODES[2573](VELOCITY_X,0) = 0.000000; -NODES[2573](VELOCITY_Y,0) = 0.000000; -NODES[2573](VELOCITY_Z,0) = 0.000000; -NODES[2574](VELOCITY_X,0) = 0.000000; -NODES[2574](VELOCITY_Y,0) = 0.000000; -NODES[2574](VELOCITY_Z,0) = 0.000000; -NODES[2575](VELOCITY_X,0) = 0.000000; -NODES[2575](VELOCITY_Y,0) = 0.000000; -NODES[2575](VELOCITY_Z,0) = 0.000000; -NODES[2576](VELOCITY_X,0) = 0.000000; -NODES[2576](VELOCITY_Y,0) = 0.000000; -NODES[2576](VELOCITY_Z,0) = 0.000000; -NODES[2579](VELOCITY_X,0) = 0.000000; -NODES[2579](VELOCITY_Y,0) = 0.000000; -NODES[2579](VELOCITY_Z,0) = 0.000000; -NODES[2580](VELOCITY_X,0) = 0.000000; -NODES[2580](VELOCITY_Y,0) = 0.000000; -NODES[2580](VELOCITY_Z,0) = 0.000000; -NODES[2584](VELOCITY_X,0) = 0.000000; -NODES[2584](VELOCITY_Y,0) = 0.000000; -NODES[2584](VELOCITY_Z,0) = 0.000000; -NODES[2585](VELOCITY_X,0) = 0.000000; -NODES[2585](VELOCITY_Y,0) = 0.000000; -NODES[2585](VELOCITY_Z,0) = 0.000000; -NODES[2587](VELOCITY_X,0) = 0.000000; -NODES[2587](VELOCITY_Y,0) = 0.000000; -NODES[2587](VELOCITY_Z,0) = 0.000000; -NODES[2589](VELOCITY_X,0) = 0.000000; -NODES[2589](VELOCITY_Y,0) = 0.000000; -NODES[2589](VELOCITY_Z,0) = 0.000000; -NODES[2591](VELOCITY_X,0) = 0.000000; -NODES[2591](VELOCITY_Y,0) = 0.000000; -NODES[2591](VELOCITY_Z,0) = 0.000000; -NODES[2596](VELOCITY_X,0) = 0.000000; -NODES[2596](VELOCITY_Y,0) = 0.000000; -NODES[2596](VELOCITY_Z,0) = 0.000000; -NODES[2597](VELOCITY_X,0) = 0.000000; -NODES[2597](VELOCITY_Y,0) = 0.000000; -NODES[2597](VELOCITY_Z,0) = 0.000000; -NODES[2599](VELOCITY_X,0) = 0.000000; -NODES[2599](VELOCITY_Y,0) = 0.000000; -NODES[2599](VELOCITY_Z,0) = 0.000000; -NODES[2600](VELOCITY_X,0) = 0.000000; -NODES[2600](VELOCITY_Y,0) = 0.000000; -NODES[2600](VELOCITY_Z,0) = 0.000000; -NODES[2603](VELOCITY_X,0) = 0.000000; -NODES[2603](VELOCITY_Y,0) = 0.000000; -NODES[2603](VELOCITY_Z,0) = 0.000000; -NODES[2604](VELOCITY_X,0) = 0.000000; -NODES[2604](VELOCITY_Y,0) = 0.000000; -NODES[2604](VELOCITY_Z,0) = 0.000000; -NODES[2608](VELOCITY_X,0) = 0.000000; -NODES[2608](VELOCITY_Y,0) = 0.000000; -NODES[2608](VELOCITY_Z,0) = 0.000000; -NODES[2612](VELOCITY_X,0) = 0.000000; -NODES[2612](VELOCITY_Y,0) = 0.000000; -NODES[2612](VELOCITY_Z,0) = 0.000000; -NODES[2617](VELOCITY_X,0) = 0.000000; -NODES[2617](VELOCITY_Y,0) = 0.000000; -NODES[2617](VELOCITY_Z,0) = 0.000000; -NODES[2621](VELOCITY_X,0) = 0.000000; -NODES[2621](VELOCITY_Y,0) = 0.000000; -NODES[2621](VELOCITY_Z,0) = 0.000000; -NODES[2622](VELOCITY_X,0) = 0.000000; -NODES[2622](VELOCITY_Y,0) = 0.000000; -NODES[2622](VELOCITY_Z,0) = 0.000000; -NODES[2624](VELOCITY_X,0) = 0.000000; -NODES[2624](VELOCITY_Y,0) = 0.000000; -NODES[2624](VELOCITY_Z,0) = 0.000000; -NODES[2625](VELOCITY_X,0) = 0.000000; -NODES[2625](VELOCITY_Y,0) = 0.000000; -NODES[2625](VELOCITY_Z,0) = 0.000000; -NODES[2629](VELOCITY_X,0) = 0.000000; -NODES[2629](VELOCITY_Y,0) = 0.000000; -NODES[2629](VELOCITY_Z,0) = 0.000000; -NODES[2631](VELOCITY_X,0) = 0.000000; -NODES[2631](VELOCITY_Y,0) = 0.000000; -NODES[2631](VELOCITY_Z,0) = 0.000000; -NODES[2632](VELOCITY_X,0) = 0.000000; -NODES[2632](VELOCITY_Y,0) = 0.000000; -NODES[2632](VELOCITY_Z,0) = 0.000000; -NODES[2633](VELOCITY_X,0) = 0.000000; -NODES[2633](VELOCITY_Y,0) = 0.000000; -NODES[2633](VELOCITY_Z,0) = 0.000000; -NODES[2643](VELOCITY_X,0) = 0.000000; -NODES[2643](VELOCITY_Y,0) = 0.000000; -NODES[2643](VELOCITY_Z,0) = 0.000000; -NODES[2645](VELOCITY_X,0) = 0.000000; -NODES[2645](VELOCITY_Y,0) = 0.000000; -NODES[2645](VELOCITY_Z,0) = 0.000000; -NODES[2646](VELOCITY_X,0) = 0.000000; -NODES[2646](VELOCITY_Y,0) = 0.000000; -NODES[2646](VELOCITY_Z,0) = 0.000000; -NODES[2656](VELOCITY_X,0) = 0.000000; -NODES[2656](VELOCITY_Y,0) = 0.000000; -NODES[2656](VELOCITY_Z,0) = 0.000000; -NODES[2657](VELOCITY_X,0) = 0.000000; -NODES[2657](VELOCITY_Y,0) = 0.000000; -NODES[2657](VELOCITY_Z,0) = 0.000000; -NODES[2658](VELOCITY_X,0) = 0.000000; -NODES[2658](VELOCITY_Y,0) = 0.000000; -NODES[2658](VELOCITY_Z,0) = 0.000000; -NODES[2661](VELOCITY_X,0) = 0.000000; -NODES[2661](VELOCITY_Y,0) = 0.000000; -NODES[2661](VELOCITY_Z,0) = 0.000000; -NODES[2663](VELOCITY_X,0) = 0.000000; -NODES[2663](VELOCITY_Y,0) = 0.000000; -NODES[2663](VELOCITY_Z,0) = 0.000000; -NODES[2668](VELOCITY_X,0) = 0.000000; -NODES[2668](VELOCITY_Y,0) = 0.000000; -NODES[2668](VELOCITY_Z,0) = 0.000000; -NODES[2669](VELOCITY_X,0) = 0.000000; -NODES[2669](VELOCITY_Y,0) = 0.000000; -NODES[2669](VELOCITY_Z,0) = 0.000000; -NODES[2678](VELOCITY_X,0) = 0.000000; -NODES[2678](VELOCITY_Y,0) = 0.000000; -NODES[2678](VELOCITY_Z,0) = 0.000000; -NODES[2679](VELOCITY_X,0) = 0.000000; -NODES[2679](VELOCITY_Y,0) = 0.000000; -NODES[2679](VELOCITY_Z,0) = 0.000000; -NODES[2684](VELOCITY_X,0) = 0.000000; -NODES[2684](VELOCITY_Y,0) = 0.000000; -NODES[2684](VELOCITY_Z,0) = 0.000000; -NODES[2685](VELOCITY_X,0) = 0.000000; -NODES[2685](VELOCITY_Y,0) = 0.000000; -NODES[2685](VELOCITY_Z,0) = 0.000000; -NODES[2690](VELOCITY_X,0) = 0.000000; -NODES[2690](VELOCITY_Y,0) = 0.000000; -NODES[2690](VELOCITY_Z,0) = 0.000000; -NODES[2691](VELOCITY_X,0) = 0.000000; -NODES[2691](VELOCITY_Y,0) = 0.000000; -NODES[2691](VELOCITY_Z,0) = 0.000000; -NODES[2693](VELOCITY_X,0) = 0.000000; -NODES[2693](VELOCITY_Y,0) = 0.000000; -NODES[2693](VELOCITY_Z,0) = 0.000000; -NODES[2698](VELOCITY_X,0) = 0.000000; -NODES[2698](VELOCITY_Y,0) = 0.000000; -NODES[2698](VELOCITY_Z,0) = 0.000000; -NODES[2702](VELOCITY_X,0) = 0.000000; -NODES[2702](VELOCITY_Y,0) = 0.000000; -NODES[2702](VELOCITY_Z,0) = 0.000000; -NODES[2707](VELOCITY_X,0) = 0.000000; -NODES[2707](VELOCITY_Y,0) = 0.000000; -NODES[2707](VELOCITY_Z,0) = 0.000000; -NODES[2712](VELOCITY_X,0) = 0.000000; -NODES[2712](VELOCITY_Y,0) = 0.000000; -NODES[2712](VELOCITY_Z,0) = 0.000000; -NODES[2726](VELOCITY_X,0) = 0.000000; -NODES[2726](VELOCITY_Y,0) = 0.000000; -NODES[2726](VELOCITY_Z,0) = 0.000000; -NODES[2730](VELOCITY_X,0) = 0.000000; -NODES[2730](VELOCITY_Y,0) = 0.000000; -NODES[2730](VELOCITY_Z,0) = 0.000000; -NODES[2731](VELOCITY_X,0) = 0.000000; -NODES[2731](VELOCITY_Y,0) = 0.000000; -NODES[2731](VELOCITY_Z,0) = 0.000000; -NODES[2732](VELOCITY_X,0) = 0.000000; -NODES[2732](VELOCITY_Y,0) = 0.000000; -NODES[2732](VELOCITY_Z,0) = 0.000000; -NODES[2737](VELOCITY_X,0) = 0.000000; -NODES[2737](VELOCITY_Y,0) = 0.000000; -NODES[2737](VELOCITY_Z,0) = 0.000000; -NODES[2754](VELOCITY_X,0) = 0.000000; -NODES[2754](VELOCITY_Y,0) = 0.000000; -NODES[2754](VELOCITY_Z,0) = 0.000000; -NODES[2755](VELOCITY_X,0) = 0.000000; -NODES[2755](VELOCITY_Y,0) = 0.000000; -NODES[2755](VELOCITY_Z,0) = 0.000000; -NODES[2757](VELOCITY_X,0) = 0.000000; -NODES[2757](VELOCITY_Y,0) = 0.000000; -NODES[2757](VELOCITY_Z,0) = 0.000000; -NODES[2758](VELOCITY_X,0) = 0.000000; -NODES[2758](VELOCITY_Y,0) = 0.000000; -NODES[2758](VELOCITY_Z,0) = 0.000000; -NODES[2759](VELOCITY_X,0) = 0.000000; -NODES[2759](VELOCITY_Y,0) = 0.000000; -NODES[2759](VELOCITY_Z,0) = 0.000000; -NODES[2764](VELOCITY_X,0) = 0.000000; -NODES[2764](VELOCITY_Y,0) = 0.000000; -NODES[2764](VELOCITY_Z,0) = 0.000000; -NODES[2766](VELOCITY_X,0) = 0.000000; -NODES[2766](VELOCITY_Y,0) = 0.000000; -NODES[2766](VELOCITY_Z,0) = 0.000000; -NODES[2769](VELOCITY_X,0) = 0.000000; -NODES[2769](VELOCITY_Y,0) = 0.000000; -NODES[2769](VELOCITY_Z,0) = 0.000000; -NODES[2773](VELOCITY_X,0) = 0.000000; -NODES[2773](VELOCITY_Y,0) = 0.000000; -NODES[2773](VELOCITY_Z,0) = 0.000000; -NODES[2780](VELOCITY_X,0) = 0.000000; -NODES[2780](VELOCITY_Y,0) = 0.000000; -NODES[2780](VELOCITY_Z,0) = 0.000000; -NODES[2782](VELOCITY_X,0) = 0.000000; -NODES[2782](VELOCITY_Y,0) = 0.000000; -NODES[2782](VELOCITY_Z,0) = 0.000000; -NODES[2785](VELOCITY_X,0) = 0.000000; -NODES[2785](VELOCITY_Y,0) = 0.000000; -NODES[2785](VELOCITY_Z,0) = 0.000000; -NODES[2786](VELOCITY_X,0) = 0.000000; -NODES[2786](VELOCITY_Y,0) = 0.000000; -NODES[2786](VELOCITY_Z,0) = 0.000000; -NODES[2787](VELOCITY_X,0) = 0.000000; -NODES[2787](VELOCITY_Y,0) = 0.000000; -NODES[2787](VELOCITY_Z,0) = 0.000000; -NODES[2790](VELOCITY_X,0) = 0.000000; -NODES[2790](VELOCITY_Y,0) = 0.000000; -NODES[2790](VELOCITY_Z,0) = 0.000000; -NODES[2791](VELOCITY_X,0) = 0.000000; -NODES[2791](VELOCITY_Y,0) = 0.000000; -NODES[2791](VELOCITY_Z,0) = 0.000000; -NODES[2795](VELOCITY_X,0) = 0.000000; -NODES[2795](VELOCITY_Y,0) = 0.000000; -NODES[2795](VELOCITY_Z,0) = 0.000000; -NODES[2796](VELOCITY_X,0) = 0.000000; -NODES[2796](VELOCITY_Y,0) = 0.000000; -NODES[2796](VELOCITY_Z,0) = 0.000000; -NODES[2802](VELOCITY_X,0) = 0.000000; -NODES[2802](VELOCITY_Y,0) = 0.000000; -NODES[2802](VELOCITY_Z,0) = 0.000000; -NODES[2807](VELOCITY_X,0) = 0.000000; -NODES[2807](VELOCITY_Y,0) = 0.000000; -NODES[2807](VELOCITY_Z,0) = 0.000000; -NODES[2809](VELOCITY_X,0) = 0.000000; -NODES[2809](VELOCITY_Y,0) = 0.000000; -NODES[2809](VELOCITY_Z,0) = 0.000000; -NODES[2810](VELOCITY_X,0) = 0.000000; -NODES[2810](VELOCITY_Y,0) = 0.000000; -NODES[2810](VELOCITY_Z,0) = 0.000000; -NODES[2814](VELOCITY_X,0) = 0.000000; -NODES[2814](VELOCITY_Y,0) = 0.000000; -NODES[2814](VELOCITY_Z,0) = 0.000000; -NODES[2815](VELOCITY_X,0) = 0.000000; -NODES[2815](VELOCITY_Y,0) = 0.000000; -NODES[2815](VELOCITY_Z,0) = 0.000000; -NODES[2821](VELOCITY_X,0) = 0.000000; -NODES[2821](VELOCITY_Y,0) = 0.000000; -NODES[2821](VELOCITY_Z,0) = 0.000000; -NODES[2822](VELOCITY_X,0) = 0.000000; -NODES[2822](VELOCITY_Y,0) = 0.000000; -NODES[2822](VELOCITY_Z,0) = 0.000000; -NODES[2824](VELOCITY_X,0) = 0.000000; -NODES[2824](VELOCITY_Y,0) = 0.000000; -NODES[2824](VELOCITY_Z,0) = 0.000000; -NODES[2829](VELOCITY_X,0) = 0.000000; -NODES[2829](VELOCITY_Y,0) = 0.000000; -NODES[2829](VELOCITY_Z,0) = 0.000000; -NODES[2837](VELOCITY_X,0) = 0.000000; -NODES[2837](VELOCITY_Y,0) = 0.000000; -NODES[2837](VELOCITY_Z,0) = 0.000000; -NODES[2839](VELOCITY_X,0) = 0.000000; -NODES[2839](VELOCITY_Y,0) = 0.000000; -NODES[2839](VELOCITY_Z,0) = 0.000000; -NODES[2848](VELOCITY_X,0) = 0.000000; -NODES[2848](VELOCITY_Y,0) = 0.000000; -NODES[2848](VELOCITY_Z,0) = 0.000000; -NODES[2850](VELOCITY_X,0) = 0.000000; -NODES[2850](VELOCITY_Y,0) = 0.000000; -NODES[2850](VELOCITY_Z,0) = 0.000000; -NODES[2856](VELOCITY_X,0) = 0.000000; -NODES[2856](VELOCITY_Y,0) = 0.000000; -NODES[2856](VELOCITY_Z,0) = 0.000000; -NODES[2857](VELOCITY_X,0) = 0.000000; -NODES[2857](VELOCITY_Y,0) = 0.000000; -NODES[2857](VELOCITY_Z,0) = 0.000000; -NODES[2861](VELOCITY_X,0) = 0.000000; -NODES[2861](VELOCITY_Y,0) = 0.000000; -NODES[2861](VELOCITY_Z,0) = 0.000000; -NODES[2862](VELOCITY_X,0) = 0.000000; -NODES[2862](VELOCITY_Y,0) = 0.000000; -NODES[2862](VELOCITY_Z,0) = 0.000000; -NODES[2867](VELOCITY_X,0) = 0.000000; -NODES[2867](VELOCITY_Y,0) = 0.000000; -NODES[2867](VELOCITY_Z,0) = 0.000000; -NODES[2873](VELOCITY_X,0) = 0.000000; -NODES[2873](VELOCITY_Y,0) = 0.000000; -NODES[2873](VELOCITY_Z,0) = 0.000000; -NODES[2874](VELOCITY_X,0) = 0.000000; -NODES[2874](VELOCITY_Y,0) = 0.000000; -NODES[2874](VELOCITY_Z,0) = 0.000000; -NODES[2877](VELOCITY_X,0) = 0.000000; -NODES[2877](VELOCITY_Y,0) = 0.000000; -NODES[2877](VELOCITY_Z,0) = 0.000000; -NODES[2879](VELOCITY_X,0) = 0.000000; -NODES[2879](VELOCITY_Y,0) = 0.000000; -NODES[2879](VELOCITY_Z,0) = 0.000000; -NODES[2887](VELOCITY_X,0) = 0.000000; -NODES[2887](VELOCITY_Y,0) = 0.000000; -NODES[2887](VELOCITY_Z,0) = 0.000000; -NODES[2893](VELOCITY_X,0) = 0.000000; -NODES[2893](VELOCITY_Y,0) = 0.000000; -NODES[2893](VELOCITY_Z,0) = 0.000000; -NODES[2894](VELOCITY_X,0) = 0.000000; -NODES[2894](VELOCITY_Y,0) = 0.000000; -NODES[2894](VELOCITY_Z,0) = 0.000000; -NODES[2896](VELOCITY_X,0) = 0.000000; -NODES[2896](VELOCITY_Y,0) = 0.000000; -NODES[2896](VELOCITY_Z,0) = 0.000000; -NODES[2897](VELOCITY_X,0) = 0.000000; -NODES[2897](VELOCITY_Y,0) = 0.000000; -NODES[2897](VELOCITY_Z,0) = 0.000000; -NODES[2901](VELOCITY_X,0) = 0.000000; -NODES[2901](VELOCITY_Y,0) = 0.000000; -NODES[2901](VELOCITY_Z,0) = 0.000000; -NODES[2903](VELOCITY_X,0) = 0.000000; -NODES[2903](VELOCITY_Y,0) = 0.000000; -NODES[2903](VELOCITY_Z,0) = 0.000000; -NODES[2907](VELOCITY_X,0) = 0.000000; -NODES[2907](VELOCITY_Y,0) = 0.000000; -NODES[2907](VELOCITY_Z,0) = 0.000000; -NODES[2908](VELOCITY_X,0) = 0.000000; -NODES[2908](VELOCITY_Y,0) = 0.000000; -NODES[2908](VELOCITY_Z,0) = 0.000000; -NODES[2909](VELOCITY_X,0) = 0.000000; -NODES[2909](VELOCITY_Y,0) = 0.000000; -NODES[2909](VELOCITY_Z,0) = 0.000000; -NODES[2915](VELOCITY_X,0) = 0.000000; -NODES[2915](VELOCITY_Y,0) = 0.000000; -NODES[2915](VELOCITY_Z,0) = 0.000000; -NODES[2918](VELOCITY_X,0) = 0.000000; -NODES[2918](VELOCITY_Y,0) = 0.000000; -NODES[2918](VELOCITY_Z,0) = 0.000000; -NODES[2921](VELOCITY_X,0) = 0.000000; -NODES[2921](VELOCITY_Y,0) = 0.000000; -NODES[2921](VELOCITY_Z,0) = 0.000000; -NODES[2922](VELOCITY_X,0) = 0.000000; -NODES[2922](VELOCITY_Y,0) = 0.000000; -NODES[2922](VELOCITY_Z,0) = 0.000000; -NODES[2923](VELOCITY_X,0) = 0.000000; -NODES[2923](VELOCITY_Y,0) = 0.000000; -NODES[2923](VELOCITY_Z,0) = 0.000000; -NODES[2929](VELOCITY_X,0) = 0.000000; -NODES[2929](VELOCITY_Y,0) = 0.000000; -NODES[2929](VELOCITY_Z,0) = 0.000000; -NODES[2933](VELOCITY_X,0) = 0.000000; -NODES[2933](VELOCITY_Y,0) = 0.000000; -NODES[2933](VELOCITY_Z,0) = 0.000000; -NODES[2934](VELOCITY_X,0) = 0.000000; -NODES[2934](VELOCITY_Y,0) = 0.000000; -NODES[2934](VELOCITY_Z,0) = 0.000000; -NODES[2937](VELOCITY_X,0) = 0.000000; -NODES[2937](VELOCITY_Y,0) = 0.000000; -NODES[2937](VELOCITY_Z,0) = 0.000000; -NODES[2939](VELOCITY_X,0) = 0.000000; -NODES[2939](VELOCITY_Y,0) = 0.000000; -NODES[2939](VELOCITY_Z,0) = 0.000000; -NODES[2942](VELOCITY_X,0) = 0.000000; -NODES[2942](VELOCITY_Y,0) = 0.000000; -NODES[2942](VELOCITY_Z,0) = 0.000000; -NODES[2950](VELOCITY_X,0) = 0.000000; -NODES[2950](VELOCITY_Y,0) = 0.000000; -NODES[2950](VELOCITY_Z,0) = 0.000000; -NODES[2951](VELOCITY_X,0) = 0.000000; -NODES[2951](VELOCITY_Y,0) = 0.000000; -NODES[2951](VELOCITY_Z,0) = 0.000000; -NODES[2958](VELOCITY_X,0) = 0.000000; -NODES[2958](VELOCITY_Y,0) = 0.000000; -NODES[2958](VELOCITY_Z,0) = 0.000000; -NODES[2966](VELOCITY_X,0) = 0.000000; -NODES[2966](VELOCITY_Y,0) = 0.000000; -NODES[2966](VELOCITY_Z,0) = 0.000000; -NODES[2967](VELOCITY_X,0) = 0.000000; -NODES[2967](VELOCITY_Y,0) = 0.000000; -NODES[2967](VELOCITY_Z,0) = 0.000000; -NODES[2968](VELOCITY_X,0) = 0.000000; -NODES[2968](VELOCITY_Y,0) = 0.000000; -NODES[2968](VELOCITY_Z,0) = 0.000000; -NODES[2972](VELOCITY_X,0) = 0.000000; -NODES[2972](VELOCITY_Y,0) = 0.000000; -NODES[2972](VELOCITY_Z,0) = 0.000000; -NODES[2975](VELOCITY_X,0) = 0.000000; -NODES[2975](VELOCITY_Y,0) = 0.000000; -NODES[2975](VELOCITY_Z,0) = 0.000000; -NODES[2977](VELOCITY_X,0) = 0.000000; -NODES[2977](VELOCITY_Y,0) = 0.000000; -NODES[2977](VELOCITY_Z,0) = 0.000000; -NODES[2982](VELOCITY_X,0) = 0.000000; -NODES[2982](VELOCITY_Y,0) = 0.000000; -NODES[2982](VELOCITY_Z,0) = 0.000000; -NODES[2983](VELOCITY_X,0) = 0.000000; -NODES[2983](VELOCITY_Y,0) = 0.000000; -NODES[2983](VELOCITY_Z,0) = 0.000000; -NODES[2990](VELOCITY_X,0) = 0.000000; -NODES[2990](VELOCITY_Y,0) = 0.000000; -NODES[2990](VELOCITY_Z,0) = 0.000000; -NODES[2991](VELOCITY_X,0) = 0.000000; -NODES[2991](VELOCITY_Y,0) = 0.000000; -NODES[2991](VELOCITY_Z,0) = 0.000000; -NODES[2992](VELOCITY_X,0) = 0.000000; -NODES[2992](VELOCITY_Y,0) = 0.000000; -NODES[2992](VELOCITY_Z,0) = 0.000000; -NODES[3001](VELOCITY_X,0) = 0.000000; -NODES[3001](VELOCITY_Y,0) = 0.000000; -NODES[3001](VELOCITY_Z,0) = 0.000000; -NODES[3003](VELOCITY_X,0) = 0.000000; -NODES[3003](VELOCITY_Y,0) = 0.000000; -NODES[3003](VELOCITY_Z,0) = 0.000000; -NODES[3004](VELOCITY_X,0) = 0.000000; -NODES[3004](VELOCITY_Y,0) = 0.000000; -NODES[3004](VELOCITY_Z,0) = 0.000000; -NODES[3005](VELOCITY_X,0) = 0.000000; -NODES[3005](VELOCITY_Y,0) = 0.000000; -NODES[3005](VELOCITY_Z,0) = 0.000000; -NODES[3006](VELOCITY_X,0) = 0.000000; -NODES[3006](VELOCITY_Y,0) = 0.000000; -NODES[3006](VELOCITY_Z,0) = 0.000000; -NODES[3021](VELOCITY_X,0) = 0.000000; -NODES[3021](VELOCITY_Y,0) = 0.000000; -NODES[3021](VELOCITY_Z,0) = 0.000000; -NODES[3028](VELOCITY_X,0) = 0.000000; -NODES[3028](VELOCITY_Y,0) = 0.000000; -NODES[3028](VELOCITY_Z,0) = 0.000000; -NODES[3029](VELOCITY_X,0) = 0.000000; -NODES[3029](VELOCITY_Y,0) = 0.000000; -NODES[3029](VELOCITY_Z,0) = 0.000000; -NODES[3030](VELOCITY_X,0) = 0.000000; -NODES[3030](VELOCITY_Y,0) = 0.000000; -NODES[3030](VELOCITY_Z,0) = 0.000000; -NODES[3033](VELOCITY_X,0) = 0.000000; -NODES[3033](VELOCITY_Y,0) = 0.000000; -NODES[3033](VELOCITY_Z,0) = 0.000000; -NODES[3034](VELOCITY_X,0) = 0.000000; -NODES[3034](VELOCITY_Y,0) = 0.000000; -NODES[3034](VELOCITY_Z,0) = 0.000000; -NODES[3039](VELOCITY_X,0) = 0.000000; -NODES[3039](VELOCITY_Y,0) = 0.000000; -NODES[3039](VELOCITY_Z,0) = 0.000000; -NODES[3045](VELOCITY_X,0) = 0.000000; -NODES[3045](VELOCITY_Y,0) = 0.000000; -NODES[3045](VELOCITY_Z,0) = 0.000000; -NODES[3048](VELOCITY_X,0) = 0.000000; -NODES[3048](VELOCITY_Y,0) = 0.000000; -NODES[3048](VELOCITY_Z,0) = 0.000000; -NODES[3051](VELOCITY_X,0) = 0.000000; -NODES[3051](VELOCITY_Y,0) = 0.000000; -NODES[3051](VELOCITY_Z,0) = 0.000000; -NODES[3054](VELOCITY_X,0) = 0.000000; -NODES[3054](VELOCITY_Y,0) = 0.000000; -NODES[3054](VELOCITY_Z,0) = 0.000000; -NODES[3055](VELOCITY_X,0) = 0.000000; -NODES[3055](VELOCITY_Y,0) = 0.000000; -NODES[3055](VELOCITY_Z,0) = 0.000000; -NODES[3058](VELOCITY_X,0) = 0.000000; -NODES[3058](VELOCITY_Y,0) = 0.000000; -NODES[3058](VELOCITY_Z,0) = 0.000000; -NODES[3059](VELOCITY_X,0) = 0.000000; -NODES[3059](VELOCITY_Y,0) = 0.000000; -NODES[3059](VELOCITY_Z,0) = 0.000000; -NODES[3063](VELOCITY_X,0) = 0.000000; -NODES[3063](VELOCITY_Y,0) = 0.000000; -NODES[3063](VELOCITY_Z,0) = 0.000000; -NODES[3079](VELOCITY_X,0) = 0.000000; -NODES[3079](VELOCITY_Y,0) = 0.000000; -NODES[3079](VELOCITY_Z,0) = 0.000000; -NODES[3083](VELOCITY_X,0) = 0.000000; -NODES[3083](VELOCITY_Y,0) = 0.000000; -NODES[3083](VELOCITY_Z,0) = 0.000000; -NODES[3085](VELOCITY_X,0) = 0.000000; -NODES[3085](VELOCITY_Y,0) = 0.000000; -NODES[3085](VELOCITY_Z,0) = 0.000000; -NODES[3086](VELOCITY_X,0) = 0.000000; -NODES[3086](VELOCITY_Y,0) = 0.000000; -NODES[3086](VELOCITY_Z,0) = 0.000000; -NODES[3091](VELOCITY_X,0) = 0.000000; -NODES[3091](VELOCITY_Y,0) = 0.000000; -NODES[3091](VELOCITY_Z,0) = 0.000000; -NODES[3093](VELOCITY_X,0) = 0.000000; -NODES[3093](VELOCITY_Y,0) = 0.000000; -NODES[3093](VELOCITY_Z,0) = 0.000000; -NODES[3097](VELOCITY_X,0) = 0.000000; -NODES[3097](VELOCITY_Y,0) = 0.000000; -NODES[3097](VELOCITY_Z,0) = 0.000000; -NODES[3099](VELOCITY_X,0) = 0.000000; -NODES[3099](VELOCITY_Y,0) = 0.000000; -NODES[3099](VELOCITY_Z,0) = 0.000000; -NODES[3100](VELOCITY_X,0) = 0.000000; -NODES[3100](VELOCITY_Y,0) = 0.000000; -NODES[3100](VELOCITY_Z,0) = 0.000000; -NODES[3101](VELOCITY_X,0) = 0.000000; -NODES[3101](VELOCITY_Y,0) = 0.000000; -NODES[3101](VELOCITY_Z,0) = 0.000000; -NODES[3105](VELOCITY_X,0) = 0.000000; -NODES[3105](VELOCITY_Y,0) = 0.000000; -NODES[3105](VELOCITY_Z,0) = 0.000000; -NODES[3110](VELOCITY_X,0) = 0.000000; -NODES[3110](VELOCITY_Y,0) = 0.000000; -NODES[3110](VELOCITY_Z,0) = 0.000000; -NODES[3119](VELOCITY_X,0) = 0.000000; -NODES[3119](VELOCITY_Y,0) = 0.000000; -NODES[3119](VELOCITY_Z,0) = 0.000000; -NODES[3121](VELOCITY_X,0) = 0.000000; -NODES[3121](VELOCITY_Y,0) = 0.000000; -NODES[3121](VELOCITY_Z,0) = 0.000000; -NODES[3131](VELOCITY_X,0) = 0.000000; -NODES[3131](VELOCITY_Y,0) = 0.000000; -NODES[3131](VELOCITY_Z,0) = 0.000000; -NODES[3134](VELOCITY_X,0) = 0.000000; -NODES[3134](VELOCITY_Y,0) = 0.000000; -NODES[3134](VELOCITY_Z,0) = 0.000000; -NODES[3153](VELOCITY_X,0) = 0.000000; -NODES[3153](VELOCITY_Y,0) = 0.000000; -NODES[3153](VELOCITY_Z,0) = 0.000000; -NODES[3161](VELOCITY_X,0) = 0.000000; -NODES[3161](VELOCITY_Y,0) = 0.000000; -NODES[3161](VELOCITY_Z,0) = 0.000000; -NODES[3165](VELOCITY_X,0) = 0.000000; -NODES[3165](VELOCITY_Y,0) = 0.000000; -NODES[3165](VELOCITY_Z,0) = 0.000000; -NODES[3166](VELOCITY_X,0) = 0.000000; -NODES[3166](VELOCITY_Y,0) = 0.000000; -NODES[3166](VELOCITY_Z,0) = 0.000000; -NODES[3167](VELOCITY_X,0) = 0.000000; -NODES[3167](VELOCITY_Y,0) = 0.000000; -NODES[3167](VELOCITY_Z,0) = 0.000000; -NODES[3170](VELOCITY_X,0) = 0.000000; -NODES[3170](VELOCITY_Y,0) = 0.000000; -NODES[3170](VELOCITY_Z,0) = 0.000000; -NODES[3171](VELOCITY_X,0) = 0.000000; -NODES[3171](VELOCITY_Y,0) = 0.000000; -NODES[3171](VELOCITY_Z,0) = 0.000000; -NODES[3177](VELOCITY_X,0) = 0.000000; -NODES[3177](VELOCITY_Y,0) = 0.000000; -NODES[3177](VELOCITY_Z,0) = 0.000000; -NODES[3194](VELOCITY_X,0) = 0.000000; -NODES[3194](VELOCITY_Y,0) = 0.000000; -NODES[3194](VELOCITY_Z,0) = 0.000000; -NODES[3199](VELOCITY_X,0) = 0.000000; -NODES[3199](VELOCITY_Y,0) = 0.000000; -NODES[3199](VELOCITY_Z,0) = 0.000000; -NODES[3217](VELOCITY_X,0) = 0.000000; -NODES[3217](VELOCITY_Y,0) = 0.000000; -NODES[3217](VELOCITY_Z,0) = 0.000000; -NODES[3218](VELOCITY_X,0) = 0.000000; -NODES[3218](VELOCITY_Y,0) = 0.000000; -NODES[3218](VELOCITY_Z,0) = 0.000000; -NODES[3220](VELOCITY_X,0) = 0.000000; -NODES[3220](VELOCITY_Y,0) = 0.000000; -NODES[3220](VELOCITY_Z,0) = 0.000000; -NODES[3225](VELOCITY_X,0) = 0.000000; -NODES[3225](VELOCITY_Y,0) = 0.000000; -NODES[3225](VELOCITY_Z,0) = 0.000000; -NODES[3228](VELOCITY_X,0) = 0.000000; -NODES[3228](VELOCITY_Y,0) = 0.000000; -NODES[3228](VELOCITY_Z,0) = 0.000000; -NODES[3240](VELOCITY_X,0) = 0.000000; -NODES[3240](VELOCITY_Y,0) = 0.000000; -NODES[3240](VELOCITY_Z,0) = 0.000000; -NODES[3241](VELOCITY_X,0) = 0.000000; -NODES[3241](VELOCITY_Y,0) = 0.000000; -NODES[3241](VELOCITY_Z,0) = 0.000000; -NODES[3243](VELOCITY_X,0) = 0.000000; -NODES[3243](VELOCITY_Y,0) = 0.000000; -NODES[3243](VELOCITY_Z,0) = 0.000000; -NODES[3251](VELOCITY_X,0) = 0.000000; -NODES[3251](VELOCITY_Y,0) = 0.000000; -NODES[3251](VELOCITY_Z,0) = 0.000000; -NODES[3258](VELOCITY_X,0) = 0.000000; -NODES[3258](VELOCITY_Y,0) = 0.000000; -NODES[3258](VELOCITY_Z,0) = 0.000000; -NODES[3264](VELOCITY_X,0) = 0.000000; -NODES[3264](VELOCITY_Y,0) = 0.000000; -NODES[3264](VELOCITY_Z,0) = 0.000000; -NODES[3265](VELOCITY_X,0) = 0.000000; -NODES[3265](VELOCITY_Y,0) = 0.000000; -NODES[3265](VELOCITY_Z,0) = 0.000000; -NODES[3268](VELOCITY_X,0) = 0.000000; -NODES[3268](VELOCITY_Y,0) = 0.000000; -NODES[3268](VELOCITY_Z,0) = 0.000000; -NODES[3270](VELOCITY_X,0) = 0.000000; -NODES[3270](VELOCITY_Y,0) = 0.000000; -NODES[3270](VELOCITY_Z,0) = 0.000000; -NODES[3272](VELOCITY_X,0) = 0.000000; -NODES[3272](VELOCITY_Y,0) = 0.000000; -NODES[3272](VELOCITY_Z,0) = 0.000000; -NODES[3275](VELOCITY_X,0) = 0.000000; -NODES[3275](VELOCITY_Y,0) = 0.000000; -NODES[3275](VELOCITY_Z,0) = 0.000000; -NODES[3276](VELOCITY_X,0) = 0.000000; -NODES[3276](VELOCITY_Y,0) = 0.000000; -NODES[3276](VELOCITY_Z,0) = 0.000000; -NODES[3278](VELOCITY_X,0) = 0.000000; -NODES[3278](VELOCITY_Y,0) = 0.000000; -NODES[3278](VELOCITY_Z,0) = 0.000000; -NODES[3279](VELOCITY_X,0) = 0.000000; -NODES[3279](VELOCITY_Y,0) = 0.000000; -NODES[3279](VELOCITY_Z,0) = 0.000000; -NODES[3280](VELOCITY_X,0) = 0.000000; -NODES[3280](VELOCITY_Y,0) = 0.000000; -NODES[3280](VELOCITY_Z,0) = 0.000000; -NODES[3282](VELOCITY_X,0) = 0.000000; -NODES[3282](VELOCITY_Y,0) = 0.000000; -NODES[3282](VELOCITY_Z,0) = 0.000000; -NODES[3283](VELOCITY_X,0) = 0.000000; -NODES[3283](VELOCITY_Y,0) = 0.000000; -NODES[3283](VELOCITY_Z,0) = 0.000000; -NODES[3287](VELOCITY_X,0) = 0.000000; -NODES[3287](VELOCITY_Y,0) = 0.000000; -NODES[3287](VELOCITY_Z,0) = 0.000000; -NODES[3293](VELOCITY_X,0) = 0.000000; -NODES[3293](VELOCITY_Y,0) = 0.000000; -NODES[3293](VELOCITY_Z,0) = 0.000000; -NODES[3294](VELOCITY_X,0) = 0.000000; -NODES[3294](VELOCITY_Y,0) = 0.000000; -NODES[3294](VELOCITY_Z,0) = 0.000000; -NODES[3297](VELOCITY_X,0) = 0.000000; -NODES[3297](VELOCITY_Y,0) = 0.000000; -NODES[3297](VELOCITY_Z,0) = 0.000000; -NODES[3301](VELOCITY_X,0) = 0.000000; -NODES[3301](VELOCITY_Y,0) = 0.000000; -NODES[3301](VELOCITY_Z,0) = 0.000000; -NODES[3302](VELOCITY_X,0) = 0.000000; -NODES[3302](VELOCITY_Y,0) = 0.000000; -NODES[3302](VELOCITY_Z,0) = 0.000000; -NODES[3303](VELOCITY_X,0) = 0.000000; -NODES[3303](VELOCITY_Y,0) = 0.000000; -NODES[3303](VELOCITY_Z,0) = 0.000000; -NODES[3309](VELOCITY_X,0) = 0.000000; -NODES[3309](VELOCITY_Y,0) = 0.000000; -NODES[3309](VELOCITY_Z,0) = 0.000000; -NODES[3311](VELOCITY_X,0) = 0.000000; -NODES[3311](VELOCITY_Y,0) = 0.000000; -NODES[3311](VELOCITY_Z,0) = 0.000000; -NODES[3315](VELOCITY_X,0) = 0.000000; -NODES[3315](VELOCITY_Y,0) = 0.000000; -NODES[3315](VELOCITY_Z,0) = 0.000000; -NODES[3322](VELOCITY_X,0) = 0.000000; -NODES[3322](VELOCITY_Y,0) = 0.000000; -NODES[3322](VELOCITY_Z,0) = 0.000000; -NODES[3323](VELOCITY_X,0) = 0.000000; -NODES[3323](VELOCITY_Y,0) = 0.000000; -NODES[3323](VELOCITY_Z,0) = 0.000000; -NODES[3324](VELOCITY_X,0) = 0.000000; -NODES[3324](VELOCITY_Y,0) = 0.000000; -NODES[3324](VELOCITY_Z,0) = 0.000000; -NODES[3325](VELOCITY_X,0) = 0.000000; -NODES[3325](VELOCITY_Y,0) = 0.000000; -NODES[3325](VELOCITY_Z,0) = 0.000000; -NODES[3341](VELOCITY_X,0) = 0.000000; -NODES[3341](VELOCITY_Y,0) = 0.000000; -NODES[3341](VELOCITY_Z,0) = 0.000000; -NODES[3345](VELOCITY_X,0) = 0.000000; -NODES[3345](VELOCITY_Y,0) = 0.000000; -NODES[3345](VELOCITY_Z,0) = 0.000000; -NODES[3346](VELOCITY_X,0) = 0.000000; -NODES[3346](VELOCITY_Y,0) = 0.000000; -NODES[3346](VELOCITY_Z,0) = 0.000000; -NODES[3348](VELOCITY_X,0) = 0.000000; -NODES[3348](VELOCITY_Y,0) = 0.000000; -NODES[3348](VELOCITY_Z,0) = 0.000000; -NODES[3350](VELOCITY_X,0) = 0.000000; -NODES[3350](VELOCITY_Y,0) = 0.000000; -NODES[3350](VELOCITY_Z,0) = 0.000000; -NODES[3352](VELOCITY_X,0) = 0.000000; -NODES[3352](VELOCITY_Y,0) = 0.000000; -NODES[3352](VELOCITY_Z,0) = 0.000000; -NODES[3354](VELOCITY_X,0) = 0.000000; -NODES[3354](VELOCITY_Y,0) = 0.000000; -NODES[3354](VELOCITY_Z,0) = 0.000000; -NODES[3359](VELOCITY_X,0) = 0.000000; -NODES[3359](VELOCITY_Y,0) = 0.000000; -NODES[3359](VELOCITY_Z,0) = 0.000000; -NODES[3366](VELOCITY_X,0) = 0.000000; -NODES[3366](VELOCITY_Y,0) = 0.000000; -NODES[3366](VELOCITY_Z,0) = 0.000000; -NODES[3368](VELOCITY_X,0) = 0.000000; -NODES[3368](VELOCITY_Y,0) = 0.000000; -NODES[3368](VELOCITY_Z,0) = 0.000000; -NODES[3372](VELOCITY_X,0) = 0.000000; -NODES[3372](VELOCITY_Y,0) = 0.000000; -NODES[3372](VELOCITY_Z,0) = 0.000000; -NODES[3377](VELOCITY_X,0) = 0.000000; -NODES[3377](VELOCITY_Y,0) = 0.000000; -NODES[3377](VELOCITY_Z,0) = 0.000000; -NODES[3380](VELOCITY_X,0) = 0.000000; -NODES[3380](VELOCITY_Y,0) = 0.000000; -NODES[3380](VELOCITY_Z,0) = 0.000000; -NODES[3389](VELOCITY_X,0) = 0.000000; -NODES[3389](VELOCITY_Y,0) = 0.000000; -NODES[3389](VELOCITY_Z,0) = 0.000000; -NODES[3390](VELOCITY_X,0) = 0.000000; -NODES[3390](VELOCITY_Y,0) = 0.000000; -NODES[3390](VELOCITY_Z,0) = 0.000000; -NODES[3395](VELOCITY_X,0) = 0.000000; -NODES[3395](VELOCITY_Y,0) = 0.000000; -NODES[3395](VELOCITY_Z,0) = 0.000000; -NODES[3399](VELOCITY_X,0) = 0.000000; -NODES[3399](VELOCITY_Y,0) = 0.000000; -NODES[3399](VELOCITY_Z,0) = 0.000000; -NODES[3400](VELOCITY_X,0) = 0.000000; -NODES[3400](VELOCITY_Y,0) = 0.000000; -NODES[3400](VELOCITY_Z,0) = 0.000000; -NODES[3405](VELOCITY_X,0) = 0.000000; -NODES[3405](VELOCITY_Y,0) = 0.000000; -NODES[3405](VELOCITY_Z,0) = 0.000000; -NODES[3408](VELOCITY_X,0) = 0.000000; -NODES[3408](VELOCITY_Y,0) = 0.000000; -NODES[3408](VELOCITY_Z,0) = 0.000000; -NODES[3412](VELOCITY_X,0) = 0.000000; -NODES[3412](VELOCITY_Y,0) = 0.000000; -NODES[3412](VELOCITY_Z,0) = 0.000000; -NODES[3422](VELOCITY_X,0) = 0.000000; -NODES[3422](VELOCITY_Y,0) = 0.000000; -NODES[3422](VELOCITY_Z,0) = 0.000000; -NODES[3436](VELOCITY_X,0) = 0.000000; -NODES[3436](VELOCITY_Y,0) = 0.000000; -NODES[3436](VELOCITY_Z,0) = 0.000000; -NODES[3439](VELOCITY_X,0) = 0.000000; -NODES[3439](VELOCITY_Y,0) = 0.000000; -NODES[3439](VELOCITY_Z,0) = 0.000000; -NODES[3449](VELOCITY_X,0) = 0.000000; -NODES[3449](VELOCITY_Y,0) = 0.000000; -NODES[3449](VELOCITY_Z,0) = 0.000000; -NODES[3454](VELOCITY_X,0) = 0.000000; -NODES[3454](VELOCITY_Y,0) = 0.000000; -NODES[3454](VELOCITY_Z,0) = 0.000000; -NODES[3455](VELOCITY_X,0) = 0.000000; -NODES[3455](VELOCITY_Y,0) = 0.000000; -NODES[3455](VELOCITY_Z,0) = 0.000000; -NODES[3456](VELOCITY_X,0) = 0.000000; -NODES[3456](VELOCITY_Y,0) = 0.000000; -NODES[3456](VELOCITY_Z,0) = 0.000000; -NODES[3461](VELOCITY_X,0) = 0.000000; -NODES[3461](VELOCITY_Y,0) = 0.000000; -NODES[3461](VELOCITY_Z,0) = 0.000000; -NODES[3463](VELOCITY_X,0) = 0.000000; -NODES[3463](VELOCITY_Y,0) = 0.000000; -NODES[3463](VELOCITY_Z,0) = 0.000000; -NODES[3465](VELOCITY_X,0) = 0.000000; -NODES[3465](VELOCITY_Y,0) = 0.000000; -NODES[3465](VELOCITY_Z,0) = 0.000000; -NODES[3474](VELOCITY_X,0) = 0.000000; -NODES[3474](VELOCITY_Y,0) = 0.000000; -NODES[3474](VELOCITY_Z,0) = 0.000000; -NODES[3475](VELOCITY_X,0) = 0.000000; -NODES[3475](VELOCITY_Y,0) = 0.000000; -NODES[3475](VELOCITY_Z,0) = 0.000000; -NODES[3477](VELOCITY_X,0) = 0.000000; -NODES[3477](VELOCITY_Y,0) = 0.000000; -NODES[3477](VELOCITY_Z,0) = 0.000000; -NODES[3481](VELOCITY_X,0) = 0.000000; -NODES[3481](VELOCITY_Y,0) = 0.000000; -NODES[3481](VELOCITY_Z,0) = 0.000000; -NODES[3487](VELOCITY_X,0) = 0.000000; -NODES[3487](VELOCITY_Y,0) = 0.000000; -NODES[3487](VELOCITY_Z,0) = 0.000000; -NODES[3493](VELOCITY_X,0) = 0.000000; -NODES[3493](VELOCITY_Y,0) = 0.000000; -NODES[3493](VELOCITY_Z,0) = 0.000000; -NODES[3495](VELOCITY_X,0) = 0.000000; -NODES[3495](VELOCITY_Y,0) = 0.000000; -NODES[3495](VELOCITY_Z,0) = 0.000000; -NODES[3496](VELOCITY_X,0) = 0.000000; -NODES[3496](VELOCITY_Y,0) = 0.000000; -NODES[3496](VELOCITY_Z,0) = 0.000000; -NODES[3500](VELOCITY_X,0) = 0.000000; -NODES[3500](VELOCITY_Y,0) = 0.000000; -NODES[3500](VELOCITY_Z,0) = 0.000000; -NODES[3521](VELOCITY_X,0) = 0.000000; -NODES[3521](VELOCITY_Y,0) = 0.000000; -NODES[3521](VELOCITY_Z,0) = 0.000000; -NODES[3524](VELOCITY_X,0) = 0.000000; -NODES[3524](VELOCITY_Y,0) = 0.000000; -NODES[3524](VELOCITY_Z,0) = 0.000000; -NODES[3529](VELOCITY_X,0) = 0.000000; -NODES[3529](VELOCITY_Y,0) = 0.000000; -NODES[3529](VELOCITY_Z,0) = 0.000000; -NODES[3531](VELOCITY_X,0) = 0.000000; -NODES[3531](VELOCITY_Y,0) = 0.000000; -NODES[3531](VELOCITY_Z,0) = 0.000000; -NODES[3532](VELOCITY_X,0) = 0.000000; -NODES[3532](VELOCITY_Y,0) = 0.000000; -NODES[3532](VELOCITY_Z,0) = 0.000000; -NODES[3539](VELOCITY_X,0) = 0.000000; -NODES[3539](VELOCITY_Y,0) = 0.000000; -NODES[3539](VELOCITY_Z,0) = 0.000000; -NODES[3541](VELOCITY_X,0) = 0.000000; -NODES[3541](VELOCITY_Y,0) = 0.000000; -NODES[3541](VELOCITY_Z,0) = 0.000000; -NODES[3543](VELOCITY_X,0) = 0.000000; -NODES[3543](VELOCITY_Y,0) = 0.000000; -NODES[3543](VELOCITY_Z,0) = 0.000000; -NODES[3558](VELOCITY_X,0) = 0.000000; -NODES[3558](VELOCITY_Y,0) = 0.000000; -NODES[3558](VELOCITY_Z,0) = 0.000000; -NODES[3567](VELOCITY_X,0) = 0.000000; -NODES[3567](VELOCITY_Y,0) = 0.000000; -NODES[3567](VELOCITY_Z,0) = 0.000000; -NODES[3571](VELOCITY_X,0) = 0.000000; -NODES[3571](VELOCITY_Y,0) = 0.000000; -NODES[3571](VELOCITY_Z,0) = 0.000000; -NODES[3580](VELOCITY_X,0) = 0.000000; -NODES[3580](VELOCITY_Y,0) = 0.000000; -NODES[3580](VELOCITY_Z,0) = 0.000000; -NODES[3585](VELOCITY_X,0) = 0.000000; -NODES[3585](VELOCITY_Y,0) = 0.000000; -NODES[3585](VELOCITY_Z,0) = 0.000000; -NODES[3587](VELOCITY_X,0) = 0.000000; -NODES[3587](VELOCITY_Y,0) = 0.000000; -NODES[3587](VELOCITY_Z,0) = 0.000000; -NODES[3615](VELOCITY_X,0) = 0.000000; -NODES[3615](VELOCITY_Y,0) = 0.000000; -NODES[3615](VELOCITY_Z,0) = 0.000000; -NODES[3620](VELOCITY_X,0) = 0.000000; -NODES[3620](VELOCITY_Y,0) = 0.000000; -NODES[3620](VELOCITY_Z,0) = 0.000000; -NODES[3621](VELOCITY_X,0) = 0.000000; -NODES[3621](VELOCITY_Y,0) = 0.000000; -NODES[3621](VELOCITY_Z,0) = 0.000000; -NODES[3624](VELOCITY_X,0) = 0.000000; -NODES[3624](VELOCITY_Y,0) = 0.000000; -NODES[3624](VELOCITY_Z,0) = 0.000000; -NODES[3626](VELOCITY_X,0) = 0.000000; -NODES[3626](VELOCITY_Y,0) = 0.000000; -NODES[3626](VELOCITY_Z,0) = 0.000000; -NODES[3627](VELOCITY_X,0) = 0.000000; -NODES[3627](VELOCITY_Y,0) = 0.000000; -NODES[3627](VELOCITY_Z,0) = 0.000000; -NODES[3628](VELOCITY_X,0) = 0.000000; -NODES[3628](VELOCITY_Y,0) = 0.000000; -NODES[3628](VELOCITY_Z,0) = 0.000000; -NODES[3633](VELOCITY_X,0) = 0.000000; -NODES[3633](VELOCITY_Y,0) = 0.000000; -NODES[3633](VELOCITY_Z,0) = 0.000000; -NODES[3645](VELOCITY_X,0) = 0.000000; -NODES[3645](VELOCITY_Y,0) = 0.000000; -NODES[3645](VELOCITY_Z,0) = 0.000000; -NODES[3648](VELOCITY_X,0) = 0.000000; -NODES[3648](VELOCITY_Y,0) = 0.000000; -NODES[3648](VELOCITY_Z,0) = 0.000000; -NODES[3650](VELOCITY_X,0) = 0.000000; -NODES[3650](VELOCITY_Y,0) = 0.000000; -NODES[3650](VELOCITY_Z,0) = 0.000000; -NODES[3653](VELOCITY_X,0) = 0.000000; -NODES[3653](VELOCITY_Y,0) = 0.000000; -NODES[3653](VELOCITY_Z,0) = 0.000000; -NODES[3657](VELOCITY_X,0) = 0.000000; -NODES[3657](VELOCITY_Y,0) = 0.000000; -NODES[3657](VELOCITY_Z,0) = 0.000000; -NODES[3664](VELOCITY_X,0) = 0.000000; -NODES[3664](VELOCITY_Y,0) = 0.000000; -NODES[3664](VELOCITY_Z,0) = 0.000000; -NODES[3674](VELOCITY_X,0) = 0.000000; -NODES[3674](VELOCITY_Y,0) = 0.000000; -NODES[3674](VELOCITY_Z,0) = 0.000000; -NODES[3685](VELOCITY_X,0) = 0.000000; -NODES[3685](VELOCITY_Y,0) = 0.000000; -NODES[3685](VELOCITY_Z,0) = 0.000000; -NODES[3689](VELOCITY_X,0) = 0.000000; -NODES[3689](VELOCITY_Y,0) = 0.000000; -NODES[3689](VELOCITY_Z,0) = 0.000000; -NODES[3690](VELOCITY_X,0) = 0.000000; -NODES[3690](VELOCITY_Y,0) = 0.000000; -NODES[3690](VELOCITY_Z,0) = 0.000000; -NODES[3693](VELOCITY_X,0) = 0.000000; -NODES[3693](VELOCITY_Y,0) = 0.000000; -NODES[3693](VELOCITY_Z,0) = 0.000000; -NODES[3694](VELOCITY_X,0) = 0.000000; -NODES[3694](VELOCITY_Y,0) = 0.000000; -NODES[3694](VELOCITY_Z,0) = 0.000000; -NODES[3695](VELOCITY_X,0) = 0.000000; -NODES[3695](VELOCITY_Y,0) = 0.000000; -NODES[3695](VELOCITY_Z,0) = 0.000000; -NODES[3697](VELOCITY_X,0) = 0.000000; -NODES[3697](VELOCITY_Y,0) = 0.000000; -NODES[3697](VELOCITY_Z,0) = 0.000000; -NODES[3701](VELOCITY_X,0) = 0.000000; -NODES[3701](VELOCITY_Y,0) = 0.000000; -NODES[3701](VELOCITY_Z,0) = 0.000000; -NODES[3702](VELOCITY_X,0) = 0.000000; -NODES[3702](VELOCITY_Y,0) = 0.000000; -NODES[3702](VELOCITY_Z,0) = 0.000000; -NODES[3703](VELOCITY_X,0) = 0.000000; -NODES[3703](VELOCITY_Y,0) = 0.000000; -NODES[3703](VELOCITY_Z,0) = 0.000000; -NODES[3705](VELOCITY_X,0) = 0.000000; -NODES[3705](VELOCITY_Y,0) = 0.000000; -NODES[3705](VELOCITY_Z,0) = 0.000000; -NODES[3706](VELOCITY_X,0) = 0.000000; -NODES[3706](VELOCITY_Y,0) = 0.000000; -NODES[3706](VELOCITY_Z,0) = 0.000000; -NODES[3707](VELOCITY_X,0) = 0.000000; -NODES[3707](VELOCITY_Y,0) = 0.000000; -NODES[3707](VELOCITY_Z,0) = 0.000000; -NODES[3709](VELOCITY_X,0) = 0.000000; -NODES[3709](VELOCITY_Y,0) = 0.000000; -NODES[3709](VELOCITY_Z,0) = 0.000000; -NODES[3710](VELOCITY_X,0) = 0.000000; -NODES[3710](VELOCITY_Y,0) = 0.000000; -NODES[3710](VELOCITY_Z,0) = 0.000000; -NODES[3711](VELOCITY_X,0) = 0.000000; -NODES[3711](VELOCITY_Y,0) = 0.000000; -NODES[3711](VELOCITY_Z,0) = 0.000000; -NODES[3715](VELOCITY_X,0) = 0.000000; -NODES[3715](VELOCITY_Y,0) = 0.000000; -NODES[3715](VELOCITY_Z,0) = 0.000000; -NODES[3718](VELOCITY_X,0) = 0.000000; -NODES[3718](VELOCITY_Y,0) = 0.000000; -NODES[3718](VELOCITY_Z,0) = 0.000000; -NODES[3722](VELOCITY_X,0) = 0.000000; -NODES[3722](VELOCITY_Y,0) = 0.000000; -NODES[3722](VELOCITY_Z,0) = 0.000000; -NODES[3724](VELOCITY_X,0) = 0.000000; -NODES[3724](VELOCITY_Y,0) = 0.000000; -NODES[3724](VELOCITY_Z,0) = 0.000000; -NODES[3729](VELOCITY_X,0) = 0.000000; -NODES[3729](VELOCITY_Y,0) = 0.000000; -NODES[3729](VELOCITY_Z,0) = 0.000000; -NODES[3732](VELOCITY_X,0) = 0.000000; -NODES[3732](VELOCITY_Y,0) = 0.000000; -NODES[3732](VELOCITY_Z,0) = 0.000000; -NODES[3733](VELOCITY_X,0) = 0.000000; -NODES[3733](VELOCITY_Y,0) = 0.000000; -NODES[3733](VELOCITY_Z,0) = 0.000000; -NODES[3735](VELOCITY_X,0) = 0.000000; -NODES[3735](VELOCITY_Y,0) = 0.000000; -NODES[3735](VELOCITY_Z,0) = 0.000000; -NODES[3736](VELOCITY_X,0) = 0.000000; -NODES[3736](VELOCITY_Y,0) = 0.000000; -NODES[3736](VELOCITY_Z,0) = 0.000000; -NODES[3742](VELOCITY_X,0) = 0.000000; -NODES[3742](VELOCITY_Y,0) = 0.000000; -NODES[3742](VELOCITY_Z,0) = 0.000000; -NODES[3749](VELOCITY_X,0) = 0.000000; -NODES[3749](VELOCITY_Y,0) = 0.000000; -NODES[3749](VELOCITY_Z,0) = 0.000000; -NODES[3750](VELOCITY_X,0) = 0.000000; -NODES[3750](VELOCITY_Y,0) = 0.000000; -NODES[3750](VELOCITY_Z,0) = 0.000000; -NODES[3753](VELOCITY_X,0) = 0.000000; -NODES[3753](VELOCITY_Y,0) = 0.000000; -NODES[3753](VELOCITY_Z,0) = 0.000000; -NODES[3757](VELOCITY_X,0) = 0.000000; -NODES[3757](VELOCITY_Y,0) = 0.000000; -NODES[3757](VELOCITY_Z,0) = 0.000000; -NODES[3758](VELOCITY_X,0) = 0.000000; -NODES[3758](VELOCITY_Y,0) = 0.000000; -NODES[3758](VELOCITY_Z,0) = 0.000000; -NODES[3759](VELOCITY_X,0) = 0.000000; -NODES[3759](VELOCITY_Y,0) = 0.000000; -NODES[3759](VELOCITY_Z,0) = 0.000000; -NODES[3761](VELOCITY_X,0) = 0.000000; -NODES[3761](VELOCITY_Y,0) = 0.000000; -NODES[3761](VELOCITY_Z,0) = 0.000000; -NODES[3775](VELOCITY_X,0) = 0.000000; -NODES[3775](VELOCITY_Y,0) = 0.000000; -NODES[3775](VELOCITY_Z,0) = 0.000000; -NODES[3790](VELOCITY_X,0) = 0.000000; -NODES[3790](VELOCITY_Y,0) = 0.000000; -NODES[3790](VELOCITY_Z,0) = 0.000000; -NODES[3791](VELOCITY_X,0) = 0.000000; -NODES[3791](VELOCITY_Y,0) = 0.000000; -NODES[3791](VELOCITY_Z,0) = 0.000000; -NODES[3792](VELOCITY_X,0) = 0.000000; -NODES[3792](VELOCITY_Y,0) = 0.000000; -NODES[3792](VELOCITY_Z,0) = 0.000000; -NODES[3803](VELOCITY_X,0) = 0.000000; -NODES[3803](VELOCITY_Y,0) = 0.000000; -NODES[3803](VELOCITY_Z,0) = 0.000000; -NODES[3804](VELOCITY_X,0) = 0.000000; -NODES[3804](VELOCITY_Y,0) = 0.000000; -NODES[3804](VELOCITY_Z,0) = 0.000000; -NODES[3806](VELOCITY_X,0) = 0.000000; -NODES[3806](VELOCITY_Y,0) = 0.000000; -NODES[3806](VELOCITY_Z,0) = 0.000000; -NODES[3821](VELOCITY_X,0) = 0.000000; -NODES[3821](VELOCITY_Y,0) = 0.000000; -NODES[3821](VELOCITY_Z,0) = 0.000000; -NODES[3824](VELOCITY_X,0) = 0.000000; -NODES[3824](VELOCITY_Y,0) = 0.000000; -NODES[3824](VELOCITY_Z,0) = 0.000000; -NODES[3830](VELOCITY_X,0) = 0.000000; -NODES[3830](VELOCITY_Y,0) = 0.000000; -NODES[3830](VELOCITY_Z,0) = 0.000000; -NODES[3833](VELOCITY_X,0) = 0.000000; -NODES[3833](VELOCITY_Y,0) = 0.000000; -NODES[3833](VELOCITY_Z,0) = 0.000000; -NODES[3836](VELOCITY_X,0) = 0.000000; -NODES[3836](VELOCITY_Y,0) = 0.000000; -NODES[3836](VELOCITY_Z,0) = 0.000000; -NODES[3841](VELOCITY_X,0) = 0.000000; -NODES[3841](VELOCITY_Y,0) = 0.000000; -NODES[3841](VELOCITY_Z,0) = 0.000000; -NODES[3849](VELOCITY_X,0) = 0.000000; -NODES[3849](VELOCITY_Y,0) = 0.000000; -NODES[3849](VELOCITY_Z,0) = 0.000000; -NODES[3850](VELOCITY_X,0) = 0.000000; -NODES[3850](VELOCITY_Y,0) = 0.000000; -NODES[3850](VELOCITY_Z,0) = 0.000000; -NODES[3858](VELOCITY_X,0) = 0.000000; -NODES[3858](VELOCITY_Y,0) = 0.000000; -NODES[3858](VELOCITY_Z,0) = 0.000000; -NODES[3859](VELOCITY_X,0) = 0.000000; -NODES[3859](VELOCITY_Y,0) = 0.000000; -NODES[3859](VELOCITY_Z,0) = 0.000000; -NODES[3865](VELOCITY_X,0) = 0.000000; -NODES[3865](VELOCITY_Y,0) = 0.000000; -NODES[3865](VELOCITY_Z,0) = 0.000000; -NODES[3870](VELOCITY_X,0) = 0.000000; -NODES[3870](VELOCITY_Y,0) = 0.000000; -NODES[3870](VELOCITY_Z,0) = 0.000000; -NODES[3872](VELOCITY_X,0) = 0.000000; -NODES[3872](VELOCITY_Y,0) = 0.000000; -NODES[3872](VELOCITY_Z,0) = 0.000000; -NODES[3887](VELOCITY_X,0) = 0.000000; -NODES[3887](VELOCITY_Y,0) = 0.000000; -NODES[3887](VELOCITY_Z,0) = 0.000000; -NODES[3889](VELOCITY_X,0) = 0.000000; -NODES[3889](VELOCITY_Y,0) = 0.000000; -NODES[3889](VELOCITY_Z,0) = 0.000000; -NODES[3891](VELOCITY_X,0) = 0.000000; -NODES[3891](VELOCITY_Y,0) = 0.000000; -NODES[3891](VELOCITY_Z,0) = 0.000000; -NODES[3896](VELOCITY_X,0) = 0.000000; -NODES[3896](VELOCITY_Y,0) = 0.000000; -NODES[3896](VELOCITY_Z,0) = 0.000000; -NODES[3901](VELOCITY_X,0) = 0.000000; -NODES[3901](VELOCITY_Y,0) = 0.000000; -NODES[3901](VELOCITY_Z,0) = 0.000000; -NODES[3915](VELOCITY_X,0) = 0.000000; -NODES[3915](VELOCITY_Y,0) = 0.000000; -NODES[3915](VELOCITY_Z,0) = 0.000000; -NODES[3920](VELOCITY_X,0) = 0.000000; -NODES[3920](VELOCITY_Y,0) = 0.000000; -NODES[3920](VELOCITY_Z,0) = 0.000000; -NODES[3921](VELOCITY_X,0) = 0.000000; -NODES[3921](VELOCITY_Y,0) = 0.000000; -NODES[3921](VELOCITY_Z,0) = 0.000000; -NODES[3923](VELOCITY_X,0) = 0.000000; -NODES[3923](VELOCITY_Y,0) = 0.000000; -NODES[3923](VELOCITY_Z,0) = 0.000000; -NODES[3929](VELOCITY_X,0) = 0.000000; -NODES[3929](VELOCITY_Y,0) = 0.000000; -NODES[3929](VELOCITY_Z,0) = 0.000000; -NODES[3931](VELOCITY_X,0) = 0.000000; -NODES[3931](VELOCITY_Y,0) = 0.000000; -NODES[3931](VELOCITY_Z,0) = 0.000000; -NODES[3937](VELOCITY_X,0) = 0.000000; -NODES[3937](VELOCITY_Y,0) = 0.000000; -NODES[3937](VELOCITY_Z,0) = 0.000000; -NODES[3938](VELOCITY_X,0) = 0.000000; -NODES[3938](VELOCITY_Y,0) = 0.000000; -NODES[3938](VELOCITY_Z,0) = 0.000000; -NODES[3953](VELOCITY_X,0) = 0.000000; -NODES[3953](VELOCITY_Y,0) = 0.000000; -NODES[3953](VELOCITY_Z,0) = 0.000000; -NODES[3963](VELOCITY_X,0) = 0.000000; -NODES[3963](VELOCITY_Y,0) = 0.000000; -NODES[3963](VELOCITY_Z,0) = 0.000000; -NODES[3968](VELOCITY_X,0) = 0.000000; -NODES[3968](VELOCITY_Y,0) = 0.000000; -NODES[3968](VELOCITY_Z,0) = 0.000000; -NODES[3969](VELOCITY_X,0) = 0.000000; -NODES[3969](VELOCITY_Y,0) = 0.000000; -NODES[3969](VELOCITY_Z,0) = 0.000000; -NODES[3972](VELOCITY_X,0) = 0.000000; -NODES[3972](VELOCITY_Y,0) = 0.000000; -NODES[3972](VELOCITY_Z,0) = 0.000000; -NODES[3975](VELOCITY_X,0) = 0.000000; -NODES[3975](VELOCITY_Y,0) = 0.000000; -NODES[3975](VELOCITY_Z,0) = 0.000000; -NODES[3981](VELOCITY_X,0) = 0.000000; -NODES[3981](VELOCITY_Y,0) = 0.000000; -NODES[3981](VELOCITY_Z,0) = 0.000000; -NODES[3987](VELOCITY_X,0) = 0.000000; -NODES[3987](VELOCITY_Y,0) = 0.000000; -NODES[3987](VELOCITY_Z,0) = 0.000000; -NODES[3997](VELOCITY_X,0) = 0.000000; -NODES[3997](VELOCITY_Y,0) = 0.000000; -NODES[3997](VELOCITY_Z,0) = 0.000000; -NODES[3998](VELOCITY_X,0) = 0.000000; -NODES[3998](VELOCITY_Y,0) = 0.000000; -NODES[3998](VELOCITY_Z,0) = 0.000000; -NODES[4002](VELOCITY_X,0) = 0.000000; -NODES[4002](VELOCITY_Y,0) = 0.000000; -NODES[4002](VELOCITY_Z,0) = 0.000000; -NODES[4006](VELOCITY_X,0) = 0.000000; -NODES[4006](VELOCITY_Y,0) = 0.000000; -NODES[4006](VELOCITY_Z,0) = 0.000000; -NODES[4018](VELOCITY_X,0) = 0.000000; -NODES[4018](VELOCITY_Y,0) = 0.000000; -NODES[4018](VELOCITY_Z,0) = 0.000000; -NODES[4020](VELOCITY_X,0) = 0.000000; -NODES[4020](VELOCITY_Y,0) = 0.000000; -NODES[4020](VELOCITY_Z,0) = 0.000000; -NODES[4021](VELOCITY_X,0) = 0.000000; -NODES[4021](VELOCITY_Y,0) = 0.000000; -NODES[4021](VELOCITY_Z,0) = 0.000000; -NODES[4024](VELOCITY_X,0) = 0.000000; -NODES[4024](VELOCITY_Y,0) = 0.000000; -NODES[4024](VELOCITY_Z,0) = 0.000000; -NODES[4038](VELOCITY_X,0) = 0.000000; -NODES[4038](VELOCITY_Y,0) = 0.000000; -NODES[4038](VELOCITY_Z,0) = 0.000000; -NODES[4042](VELOCITY_X,0) = 0.000000; -NODES[4042](VELOCITY_Y,0) = 0.000000; -NODES[4042](VELOCITY_Z,0) = 0.000000; -NODES[4046](VELOCITY_X,0) = 0.000000; -NODES[4046](VELOCITY_Y,0) = 0.000000; -NODES[4046](VELOCITY_Z,0) = 0.000000; -NODES[4050](VELOCITY_X,0) = 0.000000; -NODES[4050](VELOCITY_Y,0) = 0.000000; -NODES[4050](VELOCITY_Z,0) = 0.000000; -NODES[4065](VELOCITY_X,0) = 0.000000; -NODES[4065](VELOCITY_Y,0) = 0.000000; -NODES[4065](VELOCITY_Z,0) = 0.000000; -NODES[4073](VELOCITY_X,0) = 0.000000; -NODES[4073](VELOCITY_Y,0) = 0.000000; -NODES[4073](VELOCITY_Z,0) = 0.000000; -NODES[4076](VELOCITY_X,0) = 0.000000; -NODES[4076](VELOCITY_Y,0) = 0.000000; -NODES[4076](VELOCITY_Z,0) = 0.000000; -NODES[4079](VELOCITY_X,0) = 0.000000; -NODES[4079](VELOCITY_Y,0) = 0.000000; -NODES[4079](VELOCITY_Z,0) = 0.000000; -NODES[4082](VELOCITY_X,0) = 0.000000; -NODES[4082](VELOCITY_Y,0) = 0.000000; -NODES[4082](VELOCITY_Z,0) = 0.000000; -NODES[4085](VELOCITY_X,0) = 0.000000; -NODES[4085](VELOCITY_Y,0) = 0.000000; -NODES[4085](VELOCITY_Z,0) = 0.000000; -NODES[4093](VELOCITY_X,0) = 0.000000; -NODES[4093](VELOCITY_Y,0) = 0.000000; -NODES[4093](VELOCITY_Z,0) = 0.000000; -NODES[4095](VELOCITY_X,0) = 0.000000; -NODES[4095](VELOCITY_Y,0) = 0.000000; -NODES[4095](VELOCITY_Z,0) = 0.000000; -NODES[4096](VELOCITY_X,0) = 0.000000; -NODES[4096](VELOCITY_Y,0) = 0.000000; -NODES[4096](VELOCITY_Z,0) = 0.000000; -NODES[4099](VELOCITY_X,0) = 0.000000; -NODES[4099](VELOCITY_Y,0) = 0.000000; -NODES[4099](VELOCITY_Z,0) = 0.000000; -NODES[4108](VELOCITY_X,0) = 0.000000; -NODES[4108](VELOCITY_Y,0) = 0.000000; -NODES[4108](VELOCITY_Z,0) = 0.000000; -NODES[4114](VELOCITY_X,0) = 0.000000; -NODES[4114](VELOCITY_Y,0) = 0.000000; -NODES[4114](VELOCITY_Z,0) = 0.000000; -NODES[4115](VELOCITY_X,0) = 0.000000; -NODES[4115](VELOCITY_Y,0) = 0.000000; -NODES[4115](VELOCITY_Z,0) = 0.000000; -NODES[4123](VELOCITY_X,0) = 0.000000; -NODES[4123](VELOCITY_Y,0) = 0.000000; -NODES[4123](VELOCITY_Z,0) = 0.000000; -NODES[4124](VELOCITY_X,0) = 0.000000; -NODES[4124](VELOCITY_Y,0) = 0.000000; -NODES[4124](VELOCITY_Z,0) = 0.000000; -NODES[4138](VELOCITY_X,0) = 0.000000; -NODES[4138](VELOCITY_Y,0) = 0.000000; -NODES[4138](VELOCITY_Z,0) = 0.000000; -NODES[4148](VELOCITY_X,0) = 0.000000; -NODES[4148](VELOCITY_Y,0) = 0.000000; -NODES[4148](VELOCITY_Z,0) = 0.000000; -NODES[4149](VELOCITY_X,0) = 0.000000; -NODES[4149](VELOCITY_Y,0) = 0.000000; -NODES[4149](VELOCITY_Z,0) = 0.000000; -NODES[4151](VELOCITY_X,0) = 0.000000; -NODES[4151](VELOCITY_Y,0) = 0.000000; -NODES[4151](VELOCITY_Z,0) = 0.000000; -NODES[4152](VELOCITY_X,0) = 0.000000; -NODES[4152](VELOCITY_Y,0) = 0.000000; -NODES[4152](VELOCITY_Z,0) = 0.000000; -NODES[4157](VELOCITY_X,0) = 0.000000; -NODES[4157](VELOCITY_Y,0) = 0.000000; -NODES[4157](VELOCITY_Z,0) = 0.000000; -NODES[4158](VELOCITY_X,0) = 0.000000; -NODES[4158](VELOCITY_Y,0) = 0.000000; -NODES[4158](VELOCITY_Z,0) = 0.000000; -NODES[4161](VELOCITY_X,0) = 0.000000; -NODES[4161](VELOCITY_Y,0) = 0.000000; -NODES[4161](VELOCITY_Z,0) = 0.000000; -NODES[4163](VELOCITY_X,0) = 0.000000; -NODES[4163](VELOCITY_Y,0) = 0.000000; -NODES[4163](VELOCITY_Z,0) = 0.000000; -NODES[4167](VELOCITY_X,0) = 0.000000; -NODES[4167](VELOCITY_Y,0) = 0.000000; -NODES[4167](VELOCITY_Z,0) = 0.000000; -NODES[4168](VELOCITY_X,0) = 0.000000; -NODES[4168](VELOCITY_Y,0) = 0.000000; -NODES[4168](VELOCITY_Z,0) = 0.000000; -NODES[4172](VELOCITY_X,0) = 0.000000; -NODES[4172](VELOCITY_Y,0) = 0.000000; -NODES[4172](VELOCITY_Z,0) = 0.000000; -NODES[4174](VELOCITY_X,0) = 0.000000; -NODES[4174](VELOCITY_Y,0) = 0.000000; -NODES[4174](VELOCITY_Z,0) = 0.000000; -NODES[4178](VELOCITY_X,0) = 0.000000; -NODES[4178](VELOCITY_Y,0) = 0.000000; -NODES[4178](VELOCITY_Z,0) = 0.000000; -NODES[4179](VELOCITY_X,0) = 0.000000; -NODES[4179](VELOCITY_Y,0) = 0.000000; -NODES[4179](VELOCITY_Z,0) = 0.000000; -NODES[4187](VELOCITY_X,0) = 0.000000; -NODES[4187](VELOCITY_Y,0) = 0.000000; -NODES[4187](VELOCITY_Z,0) = 0.000000; -NODES[4188](VELOCITY_X,0) = 0.000000; -NODES[4188](VELOCITY_Y,0) = 0.000000; -NODES[4188](VELOCITY_Z,0) = 0.000000; -NODES[4191](VELOCITY_X,0) = 0.000000; -NODES[4191](VELOCITY_Y,0) = 0.000000; -NODES[4191](VELOCITY_Z,0) = 0.000000; -NODES[4192](VELOCITY_X,0) = 0.000000; -NODES[4192](VELOCITY_Y,0) = 0.000000; -NODES[4192](VELOCITY_Z,0) = 0.000000; -NODES[4197](VELOCITY_X,0) = 0.000000; -NODES[4197](VELOCITY_Y,0) = 0.000000; -NODES[4197](VELOCITY_Z,0) = 0.000000; -NODES[4200](VELOCITY_X,0) = 0.000000; -NODES[4200](VELOCITY_Y,0) = 0.000000; -NODES[4200](VELOCITY_Z,0) = 0.000000; -NODES[4201](VELOCITY_X,0) = 0.000000; -NODES[4201](VELOCITY_Y,0) = 0.000000; -NODES[4201](VELOCITY_Z,0) = 0.000000; -NODES[4211](VELOCITY_X,0) = 0.000000; -NODES[4211](VELOCITY_Y,0) = 0.000000; -NODES[4211](VELOCITY_Z,0) = 0.000000; -NODES[4227](VELOCITY_X,0) = 0.000000; -NODES[4227](VELOCITY_Y,0) = 0.000000; -NODES[4227](VELOCITY_Z,0) = 0.000000; -NODES[4235](VELOCITY_X,0) = 0.000000; -NODES[4235](VELOCITY_Y,0) = 0.000000; -NODES[4235](VELOCITY_Z,0) = 0.000000; -NODES[4236](VELOCITY_X,0) = 0.000000; -NODES[4236](VELOCITY_Y,0) = 0.000000; -NODES[4236](VELOCITY_Z,0) = 0.000000; -NODES[4245](VELOCITY_X,0) = 0.000000; -NODES[4245](VELOCITY_Y,0) = 0.000000; -NODES[4245](VELOCITY_Z,0) = 0.000000; -NODES[4246](VELOCITY_X,0) = 0.000000; -NODES[4246](VELOCITY_Y,0) = 0.000000; -NODES[4246](VELOCITY_Z,0) = 0.000000; -NODES[4247](VELOCITY_X,0) = 0.000000; -NODES[4247](VELOCITY_Y,0) = 0.000000; -NODES[4247](VELOCITY_Z,0) = 0.000000; -NODES[4252](VELOCITY_X,0) = 0.000000; -NODES[4252](VELOCITY_Y,0) = 0.000000; -NODES[4252](VELOCITY_Z,0) = 0.000000; -NODES[4256](VELOCITY_X,0) = 0.000000; -NODES[4256](VELOCITY_Y,0) = 0.000000; -NODES[4256](VELOCITY_Z,0) = 0.000000; -NODES[4257](VELOCITY_X,0) = 0.000000; -NODES[4257](VELOCITY_Y,0) = 0.000000; -NODES[4257](VELOCITY_Z,0) = 0.000000; -NODES[4270](VELOCITY_X,0) = 0.000000; -NODES[4270](VELOCITY_Y,0) = 0.000000; -NODES[4270](VELOCITY_Z,0) = 0.000000; -NODES[4277](VELOCITY_X,0) = 0.000000; -NODES[4277](VELOCITY_Y,0) = 0.000000; -NODES[4277](VELOCITY_Z,0) = 0.000000; -NODES[4283](VELOCITY_X,0) = 0.000000; -NODES[4283](VELOCITY_Y,0) = 0.000000; -NODES[4283](VELOCITY_Z,0) = 0.000000; -NODES[4298](VELOCITY_X,0) = 0.000000; -NODES[4298](VELOCITY_Y,0) = 0.000000; -NODES[4298](VELOCITY_Z,0) = 0.000000; -NODES[4299](VELOCITY_X,0) = 0.000000; -NODES[4299](VELOCITY_Y,0) = 0.000000; -NODES[4299](VELOCITY_Z,0) = 0.000000; -NODES[4309](VELOCITY_X,0) = 0.000000; -NODES[4309](VELOCITY_Y,0) = 0.000000; -NODES[4309](VELOCITY_Z,0) = 0.000000; -NODES[4310](VELOCITY_X,0) = 0.000000; -NODES[4310](VELOCITY_Y,0) = 0.000000; -NODES[4310](VELOCITY_Z,0) = 0.000000; -NODES[4313](VELOCITY_X,0) = 0.000000; -NODES[4313](VELOCITY_Y,0) = 0.000000; -NODES[4313](VELOCITY_Z,0) = 0.000000; -NODES[4316](VELOCITY_X,0) = 0.000000; -NODES[4316](VELOCITY_Y,0) = 0.000000; -NODES[4316](VELOCITY_Z,0) = 0.000000; -NODES[4329](VELOCITY_X,0) = 0.000000; -NODES[4329](VELOCITY_Y,0) = 0.000000; -NODES[4329](VELOCITY_Z,0) = 0.000000; -NODES[4332](VELOCITY_X,0) = 0.000000; -NODES[4332](VELOCITY_Y,0) = 0.000000; -NODES[4332](VELOCITY_Z,0) = 0.000000; -NODES[4333](VELOCITY_X,0) = 0.000000; -NODES[4333](VELOCITY_Y,0) = 0.000000; -NODES[4333](VELOCITY_Z,0) = 0.000000; -NODES[4336](VELOCITY_X,0) = 0.000000; -NODES[4336](VELOCITY_Y,0) = 0.000000; -NODES[4336](VELOCITY_Z,0) = 0.000000; -NODES[4342](VELOCITY_X,0) = 0.000000; -NODES[4342](VELOCITY_Y,0) = 0.000000; -NODES[4342](VELOCITY_Z,0) = 0.000000; -NODES[4346](VELOCITY_X,0) = 0.000000; -NODES[4346](VELOCITY_Y,0) = 0.000000; -NODES[4346](VELOCITY_Z,0) = 0.000000; -NODES[4347](VELOCITY_X,0) = 0.000000; -NODES[4347](VELOCITY_Y,0) = 0.000000; -NODES[4347](VELOCITY_Z,0) = 0.000000; -NODES[4358](VELOCITY_X,0) = 0.000000; -NODES[4358](VELOCITY_Y,0) = 0.000000; -NODES[4358](VELOCITY_Z,0) = 0.000000; -NODES[4366](VELOCITY_X,0) = 0.000000; -NODES[4366](VELOCITY_Y,0) = 0.000000; -NODES[4366](VELOCITY_Z,0) = 0.000000; -NODES[4373](VELOCITY_X,0) = 0.000000; -NODES[4373](VELOCITY_Y,0) = 0.000000; -NODES[4373](VELOCITY_Z,0) = 0.000000; -NODES[4374](VELOCITY_X,0) = 0.000000; -NODES[4374](VELOCITY_Y,0) = 0.000000; -NODES[4374](VELOCITY_Z,0) = 0.000000; -NODES[4382](VELOCITY_X,0) = 0.000000; -NODES[4382](VELOCITY_Y,0) = 0.000000; -NODES[4382](VELOCITY_Z,0) = 0.000000; -NODES[4394](VELOCITY_X,0) = 0.000000; -NODES[4394](VELOCITY_Y,0) = 0.000000; -NODES[4394](VELOCITY_Z,0) = 0.000000; -NODES[4396](VELOCITY_X,0) = 0.000000; -NODES[4396](VELOCITY_Y,0) = 0.000000; -NODES[4396](VELOCITY_Z,0) = 0.000000; -NODES[4397](VELOCITY_X,0) = 0.000000; -NODES[4397](VELOCITY_Y,0) = 0.000000; -NODES[4397](VELOCITY_Z,0) = 0.000000; -NODES[4398](VELOCITY_X,0) = 0.000000; -NODES[4398](VELOCITY_Y,0) = 0.000000; -NODES[4398](VELOCITY_Z,0) = 0.000000; -NODES[4400](VELOCITY_X,0) = 0.000000; -NODES[4400](VELOCITY_Y,0) = 0.000000; -NODES[4400](VELOCITY_Z,0) = 0.000000; -NODES[4401](VELOCITY_X,0) = 0.000000; -NODES[4401](VELOCITY_Y,0) = 0.000000; -NODES[4401](VELOCITY_Z,0) = 0.000000; -NODES[4402](VELOCITY_X,0) = 0.000000; -NODES[4402](VELOCITY_Y,0) = 0.000000; -NODES[4402](VELOCITY_Z,0) = 0.000000; -NODES[4412](VELOCITY_X,0) = 0.000000; -NODES[4412](VELOCITY_Y,0) = 0.000000; -NODES[4412](VELOCITY_Z,0) = 0.000000; -NODES[4435](VELOCITY_X,0) = 0.000000; -NODES[4435](VELOCITY_Y,0) = 0.000000; -NODES[4435](VELOCITY_Z,0) = 0.000000; -NODES[4438](VELOCITY_X,0) = 0.000000; -NODES[4438](VELOCITY_Y,0) = 0.000000; -NODES[4438](VELOCITY_Z,0) = 0.000000; -NODES[4455](VELOCITY_X,0) = 0.000000; -NODES[4455](VELOCITY_Y,0) = 0.000000; -NODES[4455](VELOCITY_Z,0) = 0.000000; -NODES[4456](VELOCITY_X,0) = 0.000000; -NODES[4456](VELOCITY_Y,0) = 0.000000; -NODES[4456](VELOCITY_Z,0) = 0.000000; -NODES[4457](VELOCITY_X,0) = 0.000000; -NODES[4457](VELOCITY_Y,0) = 0.000000; -NODES[4457](VELOCITY_Z,0) = 0.000000; -NODES[4458](VELOCITY_X,0) = 0.000000; -NODES[4458](VELOCITY_Y,0) = 0.000000; -NODES[4458](VELOCITY_Z,0) = 0.000000; -NODES[4470](VELOCITY_X,0) = 0.000000; -NODES[4470](VELOCITY_Y,0) = 0.000000; -NODES[4470](VELOCITY_Z,0) = 0.000000; -NODES[4484](VELOCITY_X,0) = 0.000000; -NODES[4484](VELOCITY_Y,0) = 0.000000; -NODES[4484](VELOCITY_Z,0) = 0.000000; -NODES[4498](VELOCITY_X,0) = 0.000000; -NODES[4498](VELOCITY_Y,0) = 0.000000; -NODES[4498](VELOCITY_Z,0) = 0.000000; -NODES[4505](VELOCITY_X,0) = 0.000000; -NODES[4505](VELOCITY_Y,0) = 0.000000; -NODES[4505](VELOCITY_Z,0) = 0.000000; -NODES[4513](VELOCITY_X,0) = 0.000000; -NODES[4513](VELOCITY_Y,0) = 0.000000; -NODES[4513](VELOCITY_Z,0) = 0.000000; -NODES[4515](VELOCITY_X,0) = 0.000000; -NODES[4515](VELOCITY_Y,0) = 0.000000; -NODES[4515](VELOCITY_Z,0) = 0.000000; -NODES[4530](VELOCITY_X,0) = 0.000000; -NODES[4530](VELOCITY_Y,0) = 0.000000; -NODES[4530](VELOCITY_Z,0) = 0.000000; -NODES[4535](VELOCITY_X,0) = 0.000000; -NODES[4535](VELOCITY_Y,0) = 0.000000; -NODES[4535](VELOCITY_Z,0) = 0.000000; -NODES[4547](VELOCITY_X,0) = 0.000000; -NODES[4547](VELOCITY_Y,0) = 0.000000; -NODES[4547](VELOCITY_Z,0) = 0.000000; -NODES[4549](VELOCITY_X,0) = 0.000000; -NODES[4549](VELOCITY_Y,0) = 0.000000; -NODES[4549](VELOCITY_Z,0) = 0.000000; -NODES[4551](VELOCITY_X,0) = 0.000000; -NODES[4551](VELOCITY_Y,0) = 0.000000; -NODES[4551](VELOCITY_Z,0) = 0.000000; -NODES[4553](VELOCITY_X,0) = 0.000000; -NODES[4553](VELOCITY_Y,0) = 0.000000; -NODES[4553](VELOCITY_Z,0) = 0.000000; -NODES[4554](VELOCITY_X,0) = 0.000000; -NODES[4554](VELOCITY_Y,0) = 0.000000; -NODES[4554](VELOCITY_Z,0) = 0.000000; -NODES[4563](VELOCITY_X,0) = 0.000000; -NODES[4563](VELOCITY_Y,0) = 0.000000; -NODES[4563](VELOCITY_Z,0) = 0.000000; -NODES[4575](VELOCITY_X,0) = 0.000000; -NODES[4575](VELOCITY_Y,0) = 0.000000; -NODES[4575](VELOCITY_Z,0) = 0.000000; -NODES[4576](VELOCITY_X,0) = 0.000000; -NODES[4576](VELOCITY_Y,0) = 0.000000; -NODES[4576](VELOCITY_Z,0) = 0.000000; -NODES[4581](VELOCITY_X,0) = 0.000000; -NODES[4581](VELOCITY_Y,0) = 0.000000; -NODES[4581](VELOCITY_Z,0) = 0.000000; -NODES[4582](VELOCITY_X,0) = 0.000000; -NODES[4582](VELOCITY_Y,0) = 0.000000; -NODES[4582](VELOCITY_Z,0) = 0.000000; -NODES[4586](VELOCITY_X,0) = 0.000000; -NODES[4586](VELOCITY_Y,0) = 0.000000; -NODES[4586](VELOCITY_Z,0) = 0.000000; -NODES[4588](VELOCITY_X,0) = 0.000000; -NODES[4588](VELOCITY_Y,0) = 0.000000; -NODES[4588](VELOCITY_Z,0) = 0.000000; -NODES[4594](VELOCITY_X,0) = 0.000000; -NODES[4594](VELOCITY_Y,0) = 0.000000; -NODES[4594](VELOCITY_Z,0) = 0.000000; -NODES[4598](VELOCITY_X,0) = 0.000000; -NODES[4598](VELOCITY_Y,0) = 0.000000; -NODES[4598](VELOCITY_Z,0) = 0.000000; -NODES[4599](VELOCITY_X,0) = 0.000000; -NODES[4599](VELOCITY_Y,0) = 0.000000; -NODES[4599](VELOCITY_Z,0) = 0.000000; -NODES[4605](VELOCITY_X,0) = 0.000000; -NODES[4605](VELOCITY_Y,0) = 0.000000; -NODES[4605](VELOCITY_Z,0) = 0.000000; -NODES[4607](VELOCITY_X,0) = 0.000000; -NODES[4607](VELOCITY_Y,0) = 0.000000; -NODES[4607](VELOCITY_Z,0) = 0.000000; -NODES[4611](VELOCITY_X,0) = 0.000000; -NODES[4611](VELOCITY_Y,0) = 0.000000; -NODES[4611](VELOCITY_Z,0) = 0.000000; -NODES[4616](VELOCITY_X,0) = 0.000000; -NODES[4616](VELOCITY_Y,0) = 0.000000; -NODES[4616](VELOCITY_Z,0) = 0.000000; -NODES[4627](VELOCITY_X,0) = 0.000000; -NODES[4627](VELOCITY_Y,0) = 0.000000; -NODES[4627](VELOCITY_Z,0) = 0.000000; -NODES[4632](VELOCITY_X,0) = 0.000000; -NODES[4632](VELOCITY_Y,0) = 0.000000; -NODES[4632](VELOCITY_Z,0) = 0.000000; -NODES[4642](VELOCITY_X,0) = 0.000000; -NODES[4642](VELOCITY_Y,0) = 0.000000; -NODES[4642](VELOCITY_Z,0) = 0.000000; -NODES[4647](VELOCITY_X,0) = 0.000000; -NODES[4647](VELOCITY_Y,0) = 0.000000; -NODES[4647](VELOCITY_Z,0) = 0.000000; -NODES[4648](VELOCITY_X,0) = 0.000000; -NODES[4648](VELOCITY_Y,0) = 0.000000; -NODES[4648](VELOCITY_Z,0) = 0.000000; -NODES[4652](VELOCITY_X,0) = 0.000000; -NODES[4652](VELOCITY_Y,0) = 0.000000; -NODES[4652](VELOCITY_Z,0) = 0.000000; -NODES[4665](VELOCITY_X,0) = 0.000000; -NODES[4665](VELOCITY_Y,0) = 0.000000; -NODES[4665](VELOCITY_Z,0) = 0.000000; -NODES[4670](VELOCITY_X,0) = 0.000000; -NODES[4670](VELOCITY_Y,0) = 0.000000; -NODES[4670](VELOCITY_Z,0) = 0.000000; -NODES[4671](VELOCITY_X,0) = 0.000000; -NODES[4671](VELOCITY_Y,0) = 0.000000; -NODES[4671](VELOCITY_Z,0) = 0.000000; -NODES[4674](VELOCITY_X,0) = 0.000000; -NODES[4674](VELOCITY_Y,0) = 0.000000; -NODES[4674](VELOCITY_Z,0) = 0.000000; -NODES[4675](VELOCITY_X,0) = 0.000000; -NODES[4675](VELOCITY_Y,0) = 0.000000; -NODES[4675](VELOCITY_Z,0) = 0.000000; -NODES[4678](VELOCITY_X,0) = 0.000000; -NODES[4678](VELOCITY_Y,0) = 0.000000; -NODES[4678](VELOCITY_Z,0) = 0.000000; -NODES[4686](VELOCITY_X,0) = 0.000000; -NODES[4686](VELOCITY_Y,0) = 0.000000; -NODES[4686](VELOCITY_Z,0) = 0.000000; -NODES[4687](VELOCITY_X,0) = 0.000000; -NODES[4687](VELOCITY_Y,0) = 0.000000; -NODES[4687](VELOCITY_Z,0) = 0.000000; -NODES[4696](VELOCITY_X,0) = 0.000000; -NODES[4696](VELOCITY_Y,0) = 0.000000; -NODES[4696](VELOCITY_Z,0) = 0.000000; -NODES[4697](VELOCITY_X,0) = 0.000000; -NODES[4697](VELOCITY_Y,0) = 0.000000; -NODES[4697](VELOCITY_Z,0) = 0.000000; -NODES[4702](VELOCITY_X,0) = 0.000000; -NODES[4702](VELOCITY_Y,0) = 0.000000; -NODES[4702](VELOCITY_Z,0) = 0.000000; -NODES[4703](VELOCITY_X,0) = 0.000000; -NODES[4703](VELOCITY_Y,0) = 0.000000; -NODES[4703](VELOCITY_Z,0) = 0.000000; -NODES[4704](VELOCITY_X,0) = 0.000000; -NODES[4704](VELOCITY_Y,0) = 0.000000; -NODES[4704](VELOCITY_Z,0) = 0.000000; -NODES[4706](VELOCITY_X,0) = 0.000000; -NODES[4706](VELOCITY_Y,0) = 0.000000; -NODES[4706](VELOCITY_Z,0) = 0.000000; -NODES[4707](VELOCITY_X,0) = 0.000000; -NODES[4707](VELOCITY_Y,0) = 0.000000; -NODES[4707](VELOCITY_Z,0) = 0.000000; -NODES[4716](VELOCITY_X,0) = 0.000000; -NODES[4716](VELOCITY_Y,0) = 0.000000; -NODES[4716](VELOCITY_Z,0) = 0.000000; -NODES[4728](VELOCITY_X,0) = 0.000000; -NODES[4728](VELOCITY_Y,0) = 0.000000; -NODES[4728](VELOCITY_Z,0) = 0.000000; -NODES[4729](VELOCITY_X,0) = 0.000000; -NODES[4729](VELOCITY_Y,0) = 0.000000; -NODES[4729](VELOCITY_Z,0) = 0.000000; -NODES[4732](VELOCITY_X,0) = 0.000000; -NODES[4732](VELOCITY_Y,0) = 0.000000; -NODES[4732](VELOCITY_Z,0) = 0.000000; -NODES[4735](VELOCITY_X,0) = 0.000000; -NODES[4735](VELOCITY_Y,0) = 0.000000; -NODES[4735](VELOCITY_Z,0) = 0.000000; -NODES[4736](VELOCITY_X,0) = 0.000000; -NODES[4736](VELOCITY_Y,0) = 0.000000; -NODES[4736](VELOCITY_Z,0) = 0.000000; -NODES[4748](VELOCITY_X,0) = 0.000000; -NODES[4748](VELOCITY_Y,0) = 0.000000; -NODES[4748](VELOCITY_Z,0) = 0.000000; -NODES[4749](VELOCITY_X,0) = 0.000000; -NODES[4749](VELOCITY_Y,0) = 0.000000; -NODES[4749](VELOCITY_Z,0) = 0.000000; -NODES[4760](VELOCITY_X,0) = 0.000000; -NODES[4760](VELOCITY_Y,0) = 0.000000; -NODES[4760](VELOCITY_Z,0) = 0.000000; -NODES[4764](VELOCITY_X,0) = 0.000000; -NODES[4764](VELOCITY_Y,0) = 0.000000; -NODES[4764](VELOCITY_Z,0) = 0.000000; -NODES[4770](VELOCITY_X,0) = 0.000000; -NODES[4770](VELOCITY_Y,0) = 0.000000; -NODES[4770](VELOCITY_Z,0) = 0.000000; -NODES[4773](VELOCITY_X,0) = 0.000000; -NODES[4773](VELOCITY_Y,0) = 0.000000; -NODES[4773](VELOCITY_Z,0) = 0.000000; -NODES[4781](VELOCITY_X,0) = 0.000000; -NODES[4781](VELOCITY_Y,0) = 0.000000; -NODES[4781](VELOCITY_Z,0) = 0.000000; -NODES[4785](VELOCITY_X,0) = 0.000000; -NODES[4785](VELOCITY_Y,0) = 0.000000; -NODES[4785](VELOCITY_Z,0) = 0.000000; -NODES[4786](VELOCITY_X,0) = 0.000000; -NODES[4786](VELOCITY_Y,0) = 0.000000; -NODES[4786](VELOCITY_Z,0) = 0.000000; -NODES[4789](VELOCITY_X,0) = 0.000000; -NODES[4789](VELOCITY_Y,0) = 0.000000; -NODES[4789](VELOCITY_Z,0) = 0.000000; -NODES[4790](VELOCITY_X,0) = 0.000000; -NODES[4790](VELOCITY_Y,0) = 0.000000; -NODES[4790](VELOCITY_Z,0) = 0.000000; -NODES[4823](VELOCITY_X,0) = 0.000000; -NODES[4823](VELOCITY_Y,0) = 0.000000; -NODES[4823](VELOCITY_Z,0) = 0.000000; -NODES[4824](VELOCITY_X,0) = 0.000000; -NODES[4824](VELOCITY_Y,0) = 0.000000; -NODES[4824](VELOCITY_Z,0) = 0.000000; -NODES[4836](VELOCITY_X,0) = 0.000000; -NODES[4836](VELOCITY_Y,0) = 0.000000; -NODES[4836](VELOCITY_Z,0) = 0.000000; -NODES[4847](VELOCITY_X,0) = 0.000000; -NODES[4847](VELOCITY_Y,0) = 0.000000; -NODES[4847](VELOCITY_Z,0) = 0.000000; -NODES[4848](VELOCITY_X,0) = 0.000000; -NODES[4848](VELOCITY_Y,0) = 0.000000; -NODES[4848](VELOCITY_Z,0) = 0.000000; -NODES[4856](VELOCITY_X,0) = 0.000000; -NODES[4856](VELOCITY_Y,0) = 0.000000; -NODES[4856](VELOCITY_Z,0) = 0.000000; -NODES[4865](VELOCITY_X,0) = 0.000000; -NODES[4865](VELOCITY_Y,0) = 0.000000; -NODES[4865](VELOCITY_Z,0) = 0.000000; -NODES[4866](VELOCITY_X,0) = 0.000000; -NODES[4866](VELOCITY_Y,0) = 0.000000; -NODES[4866](VELOCITY_Z,0) = 0.000000; -NODES[4868](VELOCITY_X,0) = 0.000000; -NODES[4868](VELOCITY_Y,0) = 0.000000; -NODES[4868](VELOCITY_Z,0) = 0.000000; -NODES[4869](VELOCITY_X,0) = 0.000000; -NODES[4869](VELOCITY_Y,0) = 0.000000; -NODES[4869](VELOCITY_Z,0) = 0.000000; -NODES[4877](VELOCITY_X,0) = 0.000000; -NODES[4877](VELOCITY_Y,0) = 0.000000; -NODES[4877](VELOCITY_Z,0) = 0.000000; -NODES[4886](VELOCITY_X,0) = 0.000000; -NODES[4886](VELOCITY_Y,0) = 0.000000; -NODES[4886](VELOCITY_Z,0) = 0.000000; -NODES[4895](VELOCITY_X,0) = 0.000000; -NODES[4895](VELOCITY_Y,0) = 0.000000; -NODES[4895](VELOCITY_Z,0) = 0.000000; -NODES[4904](VELOCITY_X,0) = 0.000000; -NODES[4904](VELOCITY_Y,0) = 0.000000; -NODES[4904](VELOCITY_Z,0) = 0.000000; -NODES[4908](VELOCITY_X,0) = 0.000000; -NODES[4908](VELOCITY_Y,0) = 0.000000; -NODES[4908](VELOCITY_Z,0) = 0.000000; -NODES[4917](VELOCITY_X,0) = 0.000000; -NODES[4917](VELOCITY_Y,0) = 0.000000; -NODES[4917](VELOCITY_Z,0) = 0.000000; -NODES[4925](VELOCITY_X,0) = 0.000000; -NODES[4925](VELOCITY_Y,0) = 0.000000; -NODES[4925](VELOCITY_Z,0) = 0.000000; -NODES[4931](VELOCITY_X,0) = 0.000000; -NODES[4931](VELOCITY_Y,0) = 0.000000; -NODES[4931](VELOCITY_Z,0) = 0.000000; -NODES[4932](VELOCITY_X,0) = 0.000000; -NODES[4932](VELOCITY_Y,0) = 0.000000; -NODES[4932](VELOCITY_Z,0) = 0.000000; -NODES[4945](VELOCITY_X,0) = 0.000000; -NODES[4945](VELOCITY_Y,0) = 0.000000; -NODES[4945](VELOCITY_Z,0) = 0.000000; -NODES[4960](VELOCITY_X,0) = 0.000000; -NODES[4960](VELOCITY_Y,0) = 0.000000; -NODES[4960](VELOCITY_Z,0) = 0.000000; -NODES[4961](VELOCITY_X,0) = 0.000000; -NODES[4961](VELOCITY_Y,0) = 0.000000; -NODES[4961](VELOCITY_Z,0) = 0.000000; -NODES[4966](VELOCITY_X,0) = 0.000000; -NODES[4966](VELOCITY_Y,0) = 0.000000; -NODES[4966](VELOCITY_Z,0) = 0.000000; -NODES[4967](VELOCITY_X,0) = 0.000000; -NODES[4967](VELOCITY_Y,0) = 0.000000; -NODES[4967](VELOCITY_Z,0) = 0.000000; -NODES[4970](VELOCITY_X,0) = 0.000000; -NODES[4970](VELOCITY_Y,0) = 0.000000; -NODES[4970](VELOCITY_Z,0) = 0.000000; -NODES[4981](VELOCITY_X,0) = 0.000000; -NODES[4981](VELOCITY_Y,0) = 0.000000; -NODES[4981](VELOCITY_Z,0) = 0.000000; -NODES[4982](VELOCITY_X,0) = 0.000000; -NODES[4982](VELOCITY_Y,0) = 0.000000; -NODES[4982](VELOCITY_Z,0) = 0.000000; -NODES[4984](VELOCITY_X,0) = 0.000000; -NODES[4984](VELOCITY_Y,0) = 0.000000; -NODES[4984](VELOCITY_Z,0) = 0.000000; -NODES[4988](VELOCITY_X,0) = 0.000000; -NODES[4988](VELOCITY_Y,0) = 0.000000; -NODES[4988](VELOCITY_Z,0) = 0.000000; -NODES[4995](VELOCITY_X,0) = 0.000000; -NODES[4995](VELOCITY_Y,0) = 0.000000; -NODES[4995](VELOCITY_Z,0) = 0.000000; -NODES[5000](VELOCITY_X,0) = 0.000000; -NODES[5000](VELOCITY_Y,0) = 0.000000; -NODES[5000](VELOCITY_Z,0) = 0.000000; -NODES[5001](VELOCITY_X,0) = 0.000000; -NODES[5001](VELOCITY_Y,0) = 0.000000; -NODES[5001](VELOCITY_Z,0) = 0.000000; -NODES[5011](VELOCITY_X,0) = 0.000000; -NODES[5011](VELOCITY_Y,0) = 0.000000; -NODES[5011](VELOCITY_Z,0) = 0.000000; -NODES[5012](VELOCITY_X,0) = 0.000000; -NODES[5012](VELOCITY_Y,0) = 0.000000; -NODES[5012](VELOCITY_Z,0) = 0.000000; -NODES[5024](VELOCITY_X,0) = 0.000000; -NODES[5024](VELOCITY_Y,0) = 0.000000; -NODES[5024](VELOCITY_Z,0) = 0.000000; -NODES[5027](VELOCITY_X,0) = 0.000000; -NODES[5027](VELOCITY_Y,0) = 0.000000; -NODES[5027](VELOCITY_Z,0) = 0.000000; -NODES[5029](VELOCITY_X,0) = 0.000000; -NODES[5029](VELOCITY_Y,0) = 0.000000; -NODES[5029](VELOCITY_Z,0) = 0.000000; -NODES[5034](VELOCITY_X,0) = 0.000000; -NODES[5034](VELOCITY_Y,0) = 0.000000; -NODES[5034](VELOCITY_Z,0) = 0.000000; -NODES[5041](VELOCITY_X,0) = 0.000000; -NODES[5041](VELOCITY_Y,0) = 0.000000; -NODES[5041](VELOCITY_Z,0) = 0.000000; -NODES[5042](VELOCITY_X,0) = 0.000000; -NODES[5042](VELOCITY_Y,0) = 0.000000; -NODES[5042](VELOCITY_Z,0) = 0.000000; -NODES[5066](VELOCITY_X,0) = 0.000000; -NODES[5066](VELOCITY_Y,0) = 0.000000; -NODES[5066](VELOCITY_Z,0) = 0.000000; -NODES[5067](VELOCITY_X,0) = 0.000000; -NODES[5067](VELOCITY_Y,0) = 0.000000; -NODES[5067](VELOCITY_Z,0) = 0.000000; -NODES[5071](VELOCITY_X,0) = 0.000000; -NODES[5071](VELOCITY_Y,0) = 0.000000; -NODES[5071](VELOCITY_Z,0) = 0.000000; -NODES[5080](VELOCITY_X,0) = 0.000000; -NODES[5080](VELOCITY_Y,0) = 0.000000; -NODES[5080](VELOCITY_Z,0) = 0.000000; -NODES[5083](VELOCITY_X,0) = 0.000000; -NODES[5083](VELOCITY_Y,0) = 0.000000; -NODES[5083](VELOCITY_Z,0) = 0.000000; -NODES[5085](VELOCITY_X,0) = 0.000000; -NODES[5085](VELOCITY_Y,0) = 0.000000; -NODES[5085](VELOCITY_Z,0) = 0.000000; -NODES[5101](VELOCITY_X,0) = 0.000000; -NODES[5101](VELOCITY_Y,0) = 0.000000; -NODES[5101](VELOCITY_Z,0) = 0.000000; -NODES[5102](VELOCITY_X,0) = 0.000000; -NODES[5102](VELOCITY_Y,0) = 0.000000; -NODES[5102](VELOCITY_Z,0) = 0.000000; -NODES[5104](VELOCITY_X,0) = 0.000000; -NODES[5104](VELOCITY_Y,0) = 0.000000; -NODES[5104](VELOCITY_Z,0) = 0.000000; -NODES[5117](VELOCITY_X,0) = 0.000000; -NODES[5117](VELOCITY_Y,0) = 0.000000; -NODES[5117](VELOCITY_Z,0) = 0.000000; -NODES[5134](VELOCITY_X,0) = 0.000000; -NODES[5134](VELOCITY_Y,0) = 0.000000; -NODES[5134](VELOCITY_Z,0) = 0.000000; -NODES[5141](VELOCITY_X,0) = 0.000000; -NODES[5141](VELOCITY_Y,0) = 0.000000; -NODES[5141](VELOCITY_Z,0) = 0.000000; -NODES[5142](VELOCITY_X,0) = 0.000000; -NODES[5142](VELOCITY_Y,0) = 0.000000; -NODES[5142](VELOCITY_Z,0) = 0.000000; -NODES[5147](VELOCITY_X,0) = 0.000000; -NODES[5147](VELOCITY_Y,0) = 0.000000; -NODES[5147](VELOCITY_Z,0) = 0.000000; -NODES[5154](VELOCITY_X,0) = 0.000000; -NODES[5154](VELOCITY_Y,0) = 0.000000; -NODES[5154](VELOCITY_Z,0) = 0.000000; -NODES[5160](VELOCITY_X,0) = 0.000000; -NODES[5160](VELOCITY_Y,0) = 0.000000; -NODES[5160](VELOCITY_Z,0) = 0.000000; -NODES[5161](VELOCITY_X,0) = 0.000000; -NODES[5161](VELOCITY_Y,0) = 0.000000; -NODES[5161](VELOCITY_Z,0) = 0.000000; -NODES[5163](VELOCITY_X,0) = 0.000000; -NODES[5163](VELOCITY_Y,0) = 0.000000; -NODES[5163](VELOCITY_Z,0) = 0.000000; -NODES[5177](VELOCITY_X,0) = 0.000000; -NODES[5177](VELOCITY_Y,0) = 0.000000; -NODES[5177](VELOCITY_Z,0) = 0.000000; -NODES[5180](VELOCITY_X,0) = 0.000000; -NODES[5180](VELOCITY_Y,0) = 0.000000; -NODES[5180](VELOCITY_Z,0) = 0.000000; -NODES[5181](VELOCITY_X,0) = 0.000000; -NODES[5181](VELOCITY_Y,0) = 0.000000; -NODES[5181](VELOCITY_Z,0) = 0.000000; -NODES[5185](VELOCITY_X,0) = 0.000000; -NODES[5185](VELOCITY_Y,0) = 0.000000; -NODES[5185](VELOCITY_Z,0) = 0.000000; -NODES[5198](VELOCITY_X,0) = 0.000000; -NODES[5198](VELOCITY_Y,0) = 0.000000; -NODES[5198](VELOCITY_Z,0) = 0.000000; -NODES[5199](VELOCITY_X,0) = 0.000000; -NODES[5199](VELOCITY_Y,0) = 0.000000; -NODES[5199](VELOCITY_Z,0) = 0.000000; -NODES[5221](VELOCITY_X,0) = 0.000000; -NODES[5221](VELOCITY_Y,0) = 0.000000; -NODES[5221](VELOCITY_Z,0) = 0.000000; -NODES[5222](VELOCITY_X,0) = 0.000000; -NODES[5222](VELOCITY_Y,0) = 0.000000; -NODES[5222](VELOCITY_Z,0) = 0.000000; -NODES[5230](VELOCITY_X,0) = 0.000000; -NODES[5230](VELOCITY_Y,0) = 0.000000; -NODES[5230](VELOCITY_Z,0) = 0.000000; -NODES[5233](VELOCITY_X,0) = 0.000000; -NODES[5233](VELOCITY_Y,0) = 0.000000; -NODES[5233](VELOCITY_Z,0) = 0.000000; -NODES[5246](VELOCITY_X,0) = 0.000000; -NODES[5246](VELOCITY_Y,0) = 0.000000; -NODES[5246](VELOCITY_Z,0) = 0.000000; -NODES[5247](VELOCITY_X,0) = 0.000000; -NODES[5247](VELOCITY_Y,0) = 0.000000; -NODES[5247](VELOCITY_Z,0) = 0.000000; -NODES[5253](VELOCITY_X,0) = 0.000000; -NODES[5253](VELOCITY_Y,0) = 0.000000; -NODES[5253](VELOCITY_Z,0) = 0.000000; -NODES[5254](VELOCITY_X,0) = 0.000000; -NODES[5254](VELOCITY_Y,0) = 0.000000; -NODES[5254](VELOCITY_Z,0) = 0.000000; -NODES[5257](VELOCITY_X,0) = 0.000000; -NODES[5257](VELOCITY_Y,0) = 0.000000; -NODES[5257](VELOCITY_Z,0) = 0.000000; -NODES[5259](VELOCITY_X,0) = 0.000000; -NODES[5259](VELOCITY_Y,0) = 0.000000; -NODES[5259](VELOCITY_Z,0) = 0.000000; -NODES[5260](VELOCITY_X,0) = 0.000000; -NODES[5260](VELOCITY_Y,0) = 0.000000; -NODES[5260](VELOCITY_Z,0) = 0.000000; -NODES[5262](VELOCITY_X,0) = 0.000000; -NODES[5262](VELOCITY_Y,0) = 0.000000; -NODES[5262](VELOCITY_Z,0) = 0.000000; -NODES[5263](VELOCITY_X,0) = 0.000000; -NODES[5263](VELOCITY_Y,0) = 0.000000; -NODES[5263](VELOCITY_Z,0) = 0.000000; -NODES[5271](VELOCITY_X,0) = 0.000000; -NODES[5271](VELOCITY_Y,0) = 0.000000; -NODES[5271](VELOCITY_Z,0) = 0.000000; -NODES[5275](VELOCITY_X,0) = 0.000000; -NODES[5275](VELOCITY_Y,0) = 0.000000; -NODES[5275](VELOCITY_Z,0) = 0.000000; -NODES[5281](VELOCITY_X,0) = 0.000000; -NODES[5281](VELOCITY_Y,0) = 0.000000; -NODES[5281](VELOCITY_Z,0) = 0.000000; -NODES[5289](VELOCITY_X,0) = 0.000000; -NODES[5289](VELOCITY_Y,0) = 0.000000; -NODES[5289](VELOCITY_Z,0) = 0.000000; -NODES[5290](VELOCITY_X,0) = 0.000000; -NODES[5290](VELOCITY_Y,0) = 0.000000; -NODES[5290](VELOCITY_Z,0) = 0.000000; -NODES[5291](VELOCITY_X,0) = 0.000000; -NODES[5291](VELOCITY_Y,0) = 0.000000; -NODES[5291](VELOCITY_Z,0) = 0.000000; -NODES[5308](VELOCITY_X,0) = 0.000000; -NODES[5308](VELOCITY_Y,0) = 0.000000; -NODES[5308](VELOCITY_Z,0) = 0.000000; -NODES[5325](VELOCITY_X,0) = 0.000000; -NODES[5325](VELOCITY_Y,0) = 0.000000; -NODES[5325](VELOCITY_Z,0) = 0.000000; -NODES[5333](VELOCITY_X,0) = 0.000000; -NODES[5333](VELOCITY_Y,0) = 0.000000; -NODES[5333](VELOCITY_Z,0) = 0.000000; -NODES[5334](VELOCITY_X,0) = 0.000000; -NODES[5334](VELOCITY_Y,0) = 0.000000; -NODES[5334](VELOCITY_Z,0) = 0.000000; -NODES[5336](VELOCITY_X,0) = 0.000000; -NODES[5336](VELOCITY_Y,0) = 0.000000; -NODES[5336](VELOCITY_Z,0) = 0.000000; -NODES[5337](VELOCITY_X,0) = 0.000000; -NODES[5337](VELOCITY_Y,0) = 0.000000; -NODES[5337](VELOCITY_Z,0) = 0.000000; -NODES[5341](VELOCITY_X,0) = 0.000000; -NODES[5341](VELOCITY_Y,0) = 0.000000; -NODES[5341](VELOCITY_Z,0) = 0.000000; -NODES[5343](VELOCITY_X,0) = 0.000000; -NODES[5343](VELOCITY_Y,0) = 0.000000; -NODES[5343](VELOCITY_Z,0) = 0.000000; -NODES[5344](VELOCITY_X,0) = 0.000000; -NODES[5344](VELOCITY_Y,0) = 0.000000; -NODES[5344](VELOCITY_Z,0) = 0.000000; -NODES[5357](VELOCITY_X,0) = 0.000000; -NODES[5357](VELOCITY_Y,0) = 0.000000; -NODES[5357](VELOCITY_Z,0) = 0.000000; -NODES[5362](VELOCITY_X,0) = 0.000000; -NODES[5362](VELOCITY_Y,0) = 0.000000; -NODES[5362](VELOCITY_Z,0) = 0.000000; -NODES[5375](VELOCITY_X,0) = 0.000000; -NODES[5375](VELOCITY_Y,0) = 0.000000; -NODES[5375](VELOCITY_Z,0) = 0.000000; -NODES[5376](VELOCITY_X,0) = 0.000000; -NODES[5376](VELOCITY_Y,0) = 0.000000; -NODES[5376](VELOCITY_Z,0) = 0.000000; -NODES[5389](VELOCITY_X,0) = 0.000000; -NODES[5389](VELOCITY_Y,0) = 0.000000; -NODES[5389](VELOCITY_Z,0) = 0.000000; -NODES[5404](VELOCITY_X,0) = 0.000000; -NODES[5404](VELOCITY_Y,0) = 0.000000; -NODES[5404](VELOCITY_Z,0) = 0.000000; -NODES[5405](VELOCITY_X,0) = 0.000000; -NODES[5405](VELOCITY_Y,0) = 0.000000; -NODES[5405](VELOCITY_Z,0) = 0.000000; -NODES[5407](VELOCITY_X,0) = 0.000000; -NODES[5407](VELOCITY_Y,0) = 0.000000; -NODES[5407](VELOCITY_Z,0) = 0.000000; -NODES[5425](VELOCITY_X,0) = 0.000000; -NODES[5425](VELOCITY_Y,0) = 0.000000; -NODES[5425](VELOCITY_Z,0) = 0.000000; -NODES[5427](VELOCITY_X,0) = 0.000000; -NODES[5427](VELOCITY_Y,0) = 0.000000; -NODES[5427](VELOCITY_Z,0) = 0.000000; -NODES[5435](VELOCITY_X,0) = 0.000000; -NODES[5435](VELOCITY_Y,0) = 0.000000; -NODES[5435](VELOCITY_Z,0) = 0.000000; -NODES[5440](VELOCITY_X,0) = 0.000000; -NODES[5440](VELOCITY_Y,0) = 0.000000; -NODES[5440](VELOCITY_Z,0) = 0.000000; -NODES[5445](VELOCITY_X,0) = 0.000000; -NODES[5445](VELOCITY_Y,0) = 0.000000; -NODES[5445](VELOCITY_Z,0) = 0.000000; -NODES[5446](VELOCITY_X,0) = 0.000000; -NODES[5446](VELOCITY_Y,0) = 0.000000; -NODES[5446](VELOCITY_Z,0) = 0.000000; -NODES[5480](VELOCITY_X,0) = 0.000000; -NODES[5480](VELOCITY_Y,0) = 0.000000; -NODES[5480](VELOCITY_Z,0) = 0.000000; -NODES[5487](VELOCITY_X,0) = 0.000000; -NODES[5487](VELOCITY_Y,0) = 0.000000; -NODES[5487](VELOCITY_Z,0) = 0.000000; -NODES[5491](VELOCITY_X,0) = 0.000000; -NODES[5491](VELOCITY_Y,0) = 0.000000; -NODES[5491](VELOCITY_Z,0) = 0.000000; -NODES[5492](VELOCITY_X,0) = 0.000000; -NODES[5492](VELOCITY_Y,0) = 0.000000; -NODES[5492](VELOCITY_Z,0) = 0.000000; -NODES[5496](VELOCITY_X,0) = 0.000000; -NODES[5496](VELOCITY_Y,0) = 0.000000; -NODES[5496](VELOCITY_Z,0) = 0.000000; -NODES[5497](VELOCITY_X,0) = 0.000000; -NODES[5497](VELOCITY_Y,0) = 0.000000; -NODES[5497](VELOCITY_Z,0) = 0.000000; -NODES[5499](VELOCITY_X,0) = 0.000000; -NODES[5499](VELOCITY_Y,0) = 0.000000; -NODES[5499](VELOCITY_Z,0) = 0.000000; -NODES[5500](VELOCITY_X,0) = 0.000000; -NODES[5500](VELOCITY_Y,0) = 0.000000; -NODES[5500](VELOCITY_Z,0) = 0.000000; -NODES[5501](VELOCITY_X,0) = 0.000000; -NODES[5501](VELOCITY_Y,0) = 0.000000; -NODES[5501](VELOCITY_Z,0) = 0.000000; -NODES[5502](VELOCITY_X,0) = 0.000000; -NODES[5502](VELOCITY_Y,0) = 0.000000; -NODES[5502](VELOCITY_Z,0) = 0.000000; -NODES[5503](VELOCITY_X,0) = 0.000000; -NODES[5503](VELOCITY_Y,0) = 0.000000; -NODES[5503](VELOCITY_Z,0) = 0.000000; -NODES[5505](VELOCITY_X,0) = 0.000000; -NODES[5505](VELOCITY_Y,0) = 0.000000; -NODES[5505](VELOCITY_Z,0) = 0.000000; -NODES[5510](VELOCITY_X,0) = 0.000000; -NODES[5510](VELOCITY_Y,0) = 0.000000; -NODES[5510](VELOCITY_Z,0) = 0.000000; -NODES[5519](VELOCITY_X,0) = 0.000000; -NODES[5519](VELOCITY_Y,0) = 0.000000; -NODES[5519](VELOCITY_Z,0) = 0.000000; -NODES[5528](VELOCITY_X,0) = 0.000000; -NODES[5528](VELOCITY_Y,0) = 0.000000; -NODES[5528](VELOCITY_Z,0) = 0.000000; -NODES[5533](VELOCITY_X,0) = 0.000000; -NODES[5533](VELOCITY_Y,0) = 0.000000; -NODES[5533](VELOCITY_Z,0) = 0.000000; -NODES[5534](VELOCITY_X,0) = 0.000000; -NODES[5534](VELOCITY_Y,0) = 0.000000; -NODES[5534](VELOCITY_Z,0) = 0.000000; -NODES[5540](VELOCITY_X,0) = 0.000000; -NODES[5540](VELOCITY_Y,0) = 0.000000; -NODES[5540](VELOCITY_Z,0) = 0.000000; -NODES[5548](VELOCITY_X,0) = 0.000000; -NODES[5548](VELOCITY_Y,0) = 0.000000; -NODES[5548](VELOCITY_Z,0) = 0.000000; -NODES[5550](VELOCITY_X,0) = 0.000000; -NODES[5550](VELOCITY_Y,0) = 0.000000; -NODES[5550](VELOCITY_Z,0) = 0.000000; -NODES[5551](VELOCITY_X,0) = 0.000000; -NODES[5551](VELOCITY_Y,0) = 0.000000; -NODES[5551](VELOCITY_Z,0) = 0.000000; -NODES[5563](VELOCITY_X,0) = 0.000000; -NODES[5563](VELOCITY_Y,0) = 0.000000; -NODES[5563](VELOCITY_Z,0) = 0.000000; -NODES[5568](VELOCITY_X,0) = 0.000000; -NODES[5568](VELOCITY_Y,0) = 0.000000; -NODES[5568](VELOCITY_Z,0) = 0.000000; -NODES[5575](VELOCITY_X,0) = 0.000000; -NODES[5575](VELOCITY_Y,0) = 0.000000; -NODES[5575](VELOCITY_Z,0) = 0.000000; -NODES[5579](VELOCITY_X,0) = 0.000000; -NODES[5579](VELOCITY_Y,0) = 0.000000; -NODES[5579](VELOCITY_Z,0) = 0.000000; -NODES[5580](VELOCITY_X,0) = 0.000000; -NODES[5580](VELOCITY_Y,0) = 0.000000; -NODES[5580](VELOCITY_Z,0) = 0.000000; -NODES[5587](VELOCITY_X,0) = 0.000000; -NODES[5587](VELOCITY_Y,0) = 0.000000; -NODES[5587](VELOCITY_Z,0) = 0.000000; -NODES[5596](VELOCITY_X,0) = 0.000000; -NODES[5596](VELOCITY_Y,0) = 0.000000; -NODES[5596](VELOCITY_Z,0) = 0.000000; -NODES[5597](VELOCITY_X,0) = 0.000000; -NODES[5597](VELOCITY_Y,0) = 0.000000; -NODES[5597](VELOCITY_Z,0) = 0.000000; -NODES[5598](VELOCITY_X,0) = 0.000000; -NODES[5598](VELOCITY_Y,0) = 0.000000; -NODES[5598](VELOCITY_Z,0) = 0.000000; -NODES[5618](VELOCITY_X,0) = 0.000000; -NODES[5618](VELOCITY_Y,0) = 0.000000; -NODES[5618](VELOCITY_Z,0) = 0.000000; -NODES[5619](VELOCITY_X,0) = 0.000000; -NODES[5619](VELOCITY_Y,0) = 0.000000; -NODES[5619](VELOCITY_Z,0) = 0.000000; -NODES[5620](VELOCITY_X,0) = 0.000000; -NODES[5620](VELOCITY_Y,0) = 0.000000; -NODES[5620](VELOCITY_Z,0) = 0.000000; -NODES[5630](VELOCITY_X,0) = 0.000000; -NODES[5630](VELOCITY_Y,0) = 0.000000; -NODES[5630](VELOCITY_Z,0) = 0.000000; -NODES[5638](VELOCITY_X,0) = 0.000000; -NODES[5638](VELOCITY_Y,0) = 0.000000; -NODES[5638](VELOCITY_Z,0) = 0.000000; -NODES[5646](VELOCITY_X,0) = 0.000000; -NODES[5646](VELOCITY_Y,0) = 0.000000; -NODES[5646](VELOCITY_Z,0) = 0.000000; -NODES[5647](VELOCITY_X,0) = 0.000000; -NODES[5647](VELOCITY_Y,0) = 0.000000; -NODES[5647](VELOCITY_Z,0) = 0.000000; -NODES[5662](VELOCITY_X,0) = 0.000000; -NODES[5662](VELOCITY_Y,0) = 0.000000; -NODES[5662](VELOCITY_Z,0) = 0.000000; -NODES[5678](VELOCITY_X,0) = 0.000000; -NODES[5678](VELOCITY_Y,0) = 0.000000; -NODES[5678](VELOCITY_Z,0) = 0.000000; -NODES[5692](VELOCITY_X,0) = 0.000000; -NODES[5692](VELOCITY_Y,0) = 0.000000; -NODES[5692](VELOCITY_Z,0) = 0.000000; -NODES[5693](VELOCITY_X,0) = 0.000000; -NODES[5693](VELOCITY_Y,0) = 0.000000; -NODES[5693](VELOCITY_Z,0) = 0.000000; -NODES[5698](VELOCITY_X,0) = 0.000000; -NODES[5698](VELOCITY_Y,0) = 0.000000; -NODES[5698](VELOCITY_Z,0) = 0.000000; -NODES[5705](VELOCITY_X,0) = 0.000000; -NODES[5705](VELOCITY_Y,0) = 0.000000; -NODES[5705](VELOCITY_Z,0) = 0.000000; -NODES[5721](VELOCITY_X,0) = 0.000000; -NODES[5721](VELOCITY_Y,0) = 0.000000; -NODES[5721](VELOCITY_Z,0) = 0.000000; -NODES[5722](VELOCITY_X,0) = 0.000000; -NODES[5722](VELOCITY_Y,0) = 0.000000; -NODES[5722](VELOCITY_Z,0) = 0.000000; -NODES[5734](VELOCITY_X,0) = 0.000000; -NODES[5734](VELOCITY_Y,0) = 0.000000; -NODES[5734](VELOCITY_Z,0) = 0.000000; -NODES[5735](VELOCITY_X,0) = 0.000000; -NODES[5735](VELOCITY_Y,0) = 0.000000; -NODES[5735](VELOCITY_Z,0) = 0.000000; -NODES[5736](VELOCITY_X,0) = 0.000000; -NODES[5736](VELOCITY_Y,0) = 0.000000; -NODES[5736](VELOCITY_Z,0) = 0.000000; -NODES[5746](VELOCITY_X,0) = 0.000000; -NODES[5746](VELOCITY_Y,0) = 0.000000; -NODES[5746](VELOCITY_Z,0) = 0.000000; -NODES[5760](VELOCITY_X,0) = 0.000000; -NODES[5760](VELOCITY_Y,0) = 0.000000; -NODES[5760](VELOCITY_Z,0) = 0.000000; -NODES[5768](VELOCITY_X,0) = 0.000000; -NODES[5768](VELOCITY_Y,0) = 0.000000; -NODES[5768](VELOCITY_Z,0) = 0.000000; -NODES[5774](VELOCITY_X,0) = 0.000000; -NODES[5774](VELOCITY_Y,0) = 0.000000; -NODES[5774](VELOCITY_Z,0) = 0.000000; -NODES[5782](VELOCITY_X,0) = 0.000000; -NODES[5782](VELOCITY_Y,0) = 0.000000; -NODES[5782](VELOCITY_Z,0) = 0.000000; -NODES[5792](VELOCITY_X,0) = 0.000000; -NODES[5792](VELOCITY_Y,0) = 0.000000; -NODES[5792](VELOCITY_Z,0) = 0.000000; -NODES[5799](VELOCITY_X,0) = 0.000000; -NODES[5799](VELOCITY_Y,0) = 0.000000; -NODES[5799](VELOCITY_Z,0) = 0.000000; -NODES[5815](VELOCITY_X,0) = 0.000000; -NODES[5815](VELOCITY_Y,0) = 0.000000; -NODES[5815](VELOCITY_Z,0) = 0.000000; -NODES[5820](VELOCITY_X,0) = 0.000000; -NODES[5820](VELOCITY_Y,0) = 0.000000; -NODES[5820](VELOCITY_Z,0) = 0.000000; -NODES[5832](VELOCITY_X,0) = 0.000000; -NODES[5832](VELOCITY_Y,0) = 0.000000; -NODES[5832](VELOCITY_Z,0) = 0.000000; -NODES[5836](VELOCITY_X,0) = 0.000000; -NODES[5836](VELOCITY_Y,0) = 0.000000; -NODES[5836](VELOCITY_Z,0) = 0.000000; -NODES[5837](VELOCITY_X,0) = 0.000000; -NODES[5837](VELOCITY_Y,0) = 0.000000; -NODES[5837](VELOCITY_Z,0) = 0.000000; -NODES[5850](VELOCITY_X,0) = 0.000000; -NODES[5850](VELOCITY_Y,0) = 0.000000; -NODES[5850](VELOCITY_Z,0) = 0.000000; -NODES[5859](VELOCITY_X,0) = 0.000000; -NODES[5859](VELOCITY_Y,0) = 0.000000; -NODES[5859](VELOCITY_Z,0) = 0.000000; -NODES[5860](VELOCITY_X,0) = 0.000000; -NODES[5860](VELOCITY_Y,0) = 0.000000; -NODES[5860](VELOCITY_Z,0) = 0.000000; -NODES[5862](VELOCITY_X,0) = 0.000000; -NODES[5862](VELOCITY_Y,0) = 0.000000; -NODES[5862](VELOCITY_Z,0) = 0.000000; -NODES[5867](VELOCITY_X,0) = 0.000000; -NODES[5867](VELOCITY_Y,0) = 0.000000; -NODES[5867](VELOCITY_Z,0) = 0.000000; -NODES[5868](VELOCITY_X,0) = 0.000000; -NODES[5868](VELOCITY_Y,0) = 0.000000; -NODES[5868](VELOCITY_Z,0) = 0.000000; -NODES[5876](VELOCITY_X,0) = 0.000000; -NODES[5876](VELOCITY_Y,0) = 0.000000; -NODES[5876](VELOCITY_Z,0) = 0.000000; -NODES[5877](VELOCITY_X,0) = 0.000000; -NODES[5877](VELOCITY_Y,0) = 0.000000; -NODES[5877](VELOCITY_Z,0) = 0.000000; -NODES[5899](VELOCITY_X,0) = 0.000000; -NODES[5899](VELOCITY_Y,0) = 0.000000; -NODES[5899](VELOCITY_Z,0) = 0.000000; -NODES[5900](VELOCITY_X,0) = 0.000000; -NODES[5900](VELOCITY_Y,0) = 0.000000; -NODES[5900](VELOCITY_Z,0) = 0.000000; -NODES[5901](VELOCITY_X,0) = 0.000000; -NODES[5901](VELOCITY_Y,0) = 0.000000; -NODES[5901](VELOCITY_Z,0) = 0.000000; -NODES[5903](VELOCITY_X,0) = 0.000000; -NODES[5903](VELOCITY_Y,0) = 0.000000; -NODES[5903](VELOCITY_Z,0) = 0.000000; -NODES[5904](VELOCITY_X,0) = 0.000000; -NODES[5904](VELOCITY_Y,0) = 0.000000; -NODES[5904](VELOCITY_Z,0) = 0.000000; -NODES[5906](VELOCITY_X,0) = 0.000000; -NODES[5906](VELOCITY_Y,0) = 0.000000; -NODES[5906](VELOCITY_Z,0) = 0.000000; -NODES[5920](VELOCITY_X,0) = 0.000000; -NODES[5920](VELOCITY_Y,0) = 0.000000; -NODES[5920](VELOCITY_Z,0) = 0.000000; -NODES[5925](VELOCITY_X,0) = 0.000000; -NODES[5925](VELOCITY_Y,0) = 0.000000; -NODES[5925](VELOCITY_Z,0) = 0.000000; -NODES[5931](VELOCITY_X,0) = 0.000000; -NODES[5931](VELOCITY_Y,0) = 0.000000; -NODES[5931](VELOCITY_Z,0) = 0.000000; -NODES[5938](VELOCITY_X,0) = 0.000000; -NODES[5938](VELOCITY_Y,0) = 0.000000; -NODES[5938](VELOCITY_Z,0) = 0.000000; -NODES[5939](VELOCITY_X,0) = 0.000000; -NODES[5939](VELOCITY_Y,0) = 0.000000; -NODES[5939](VELOCITY_Z,0) = 0.000000; -NODES[5946](VELOCITY_X,0) = 0.000000; -NODES[5946](VELOCITY_Y,0) = 0.000000; -NODES[5946](VELOCITY_Z,0) = 0.000000; -NODES[5960](VELOCITY_X,0) = 0.000000; -NODES[5960](VELOCITY_Y,0) = 0.000000; -NODES[5960](VELOCITY_Z,0) = 0.000000; -NODES[5961](VELOCITY_X,0) = 0.000000; -NODES[5961](VELOCITY_Y,0) = 0.000000; -NODES[5961](VELOCITY_Z,0) = 0.000000; -NODES[5962](VELOCITY_X,0) = 0.000000; -NODES[5962](VELOCITY_Y,0) = 0.000000; -NODES[5962](VELOCITY_Z,0) = 0.000000; -NODES[5964](VELOCITY_X,0) = 0.000000; -NODES[5964](VELOCITY_Y,0) = 0.000000; -NODES[5964](VELOCITY_Z,0) = 0.000000; -NODES[5972](VELOCITY_X,0) = 0.000000; -NODES[5972](VELOCITY_Y,0) = 0.000000; -NODES[5972](VELOCITY_Z,0) = 0.000000; -NODES[5987](VELOCITY_X,0) = 0.000000; -NODES[5987](VELOCITY_Y,0) = 0.000000; -NODES[5987](VELOCITY_Z,0) = 0.000000; -NODES[5988](VELOCITY_X,0) = 0.000000; -NODES[5988](VELOCITY_Y,0) = 0.000000; -NODES[5988](VELOCITY_Z,0) = 0.000000; -NODES[6016](VELOCITY_X,0) = 0.000000; -NODES[6016](VELOCITY_Y,0) = 0.000000; -NODES[6016](VELOCITY_Z,0) = 0.000000; -NODES[6025](VELOCITY_X,0) = 0.000000; -NODES[6025](VELOCITY_Y,0) = 0.000000; -NODES[6025](VELOCITY_Z,0) = 0.000000; -NODES[6026](VELOCITY_X,0) = 0.000000; -NODES[6026](VELOCITY_Y,0) = 0.000000; -NODES[6026](VELOCITY_Z,0) = 0.000000; -NODES[6033](VELOCITY_X,0) = 0.000000; -NODES[6033](VELOCITY_Y,0) = 0.000000; -NODES[6033](VELOCITY_Z,0) = 0.000000; -NODES[6036](VELOCITY_X,0) = 0.000000; -NODES[6036](VELOCITY_Y,0) = 0.000000; -NODES[6036](VELOCITY_Z,0) = 0.000000; -NODES[6041](VELOCITY_X,0) = 0.000000; -NODES[6041](VELOCITY_Y,0) = 0.000000; -NODES[6041](VELOCITY_Z,0) = 0.000000; -NODES[6045](VELOCITY_X,0) = 0.000000; -NODES[6045](VELOCITY_Y,0) = 0.000000; -NODES[6045](VELOCITY_Z,0) = 0.000000; -NODES[6054](VELOCITY_X,0) = 0.000000; -NODES[6054](VELOCITY_Y,0) = 0.000000; -NODES[6054](VELOCITY_Z,0) = 0.000000; -NODES[6056](VELOCITY_X,0) = 0.000000; -NODES[6056](VELOCITY_Y,0) = 0.000000; -NODES[6056](VELOCITY_Z,0) = 0.000000; -NODES[6057](VELOCITY_X,0) = 0.000000; -NODES[6057](VELOCITY_Y,0) = 0.000000; -NODES[6057](VELOCITY_Z,0) = 0.000000; -NODES[6070](VELOCITY_X,0) = 0.000000; -NODES[6070](VELOCITY_Y,0) = 0.000000; -NODES[6070](VELOCITY_Z,0) = 0.000000; -NODES[6071](VELOCITY_X,0) = 0.000000; -NODES[6071](VELOCITY_Y,0) = 0.000000; -NODES[6071](VELOCITY_Z,0) = 0.000000; -NODES[6074](VELOCITY_X,0) = 0.000000; -NODES[6074](VELOCITY_Y,0) = 0.000000; -NODES[6074](VELOCITY_Z,0) = 0.000000; -NODES[6077](VELOCITY_X,0) = 0.000000; -NODES[6077](VELOCITY_Y,0) = 0.000000; -NODES[6077](VELOCITY_Z,0) = 0.000000; -NODES[6085](VELOCITY_X,0) = 0.000000; -NODES[6085](VELOCITY_Y,0) = 0.000000; -NODES[6085](VELOCITY_Z,0) = 0.000000; -NODES[6089](VELOCITY_X,0) = 0.000000; -NODES[6089](VELOCITY_Y,0) = 0.000000; -NODES[6089](VELOCITY_Z,0) = 0.000000; -NODES[6095](VELOCITY_X,0) = 0.000000; -NODES[6095](VELOCITY_Y,0) = 0.000000; -NODES[6095](VELOCITY_Z,0) = 0.000000; -NODES[6096](VELOCITY_X,0) = 0.000000; -NODES[6096](VELOCITY_Y,0) = 0.000000; -NODES[6096](VELOCITY_Z,0) = 0.000000; -NODES[6107](VELOCITY_X,0) = 0.000000; -NODES[6107](VELOCITY_Y,0) = 0.000000; -NODES[6107](VELOCITY_Z,0) = 0.000000; -NODES[6108](VELOCITY_X,0) = 0.000000; -NODES[6108](VELOCITY_Y,0) = 0.000000; -NODES[6108](VELOCITY_Z,0) = 0.000000; -NODES[6122](VELOCITY_X,0) = 0.000000; -NODES[6122](VELOCITY_Y,0) = 0.000000; -NODES[6122](VELOCITY_Z,0) = 0.000000; -NODES[6124](VELOCITY_X,0) = 0.000000; -NODES[6124](VELOCITY_Y,0) = 0.000000; -NODES[6124](VELOCITY_Z,0) = 0.000000; -NODES[6128](VELOCITY_X,0) = 0.000000; -NODES[6128](VELOCITY_Y,0) = 0.000000; -NODES[6128](VELOCITY_Z,0) = 0.000000; -NODES[6129](VELOCITY_X,0) = 0.000000; -NODES[6129](VELOCITY_Y,0) = 0.000000; -NODES[6129](VELOCITY_Z,0) = 0.000000; -NODES[6135](VELOCITY_X,0) = 0.000000; -NODES[6135](VELOCITY_Y,0) = 0.000000; -NODES[6135](VELOCITY_Z,0) = 0.000000; -NODES[6136](VELOCITY_X,0) = 0.000000; -NODES[6136](VELOCITY_Y,0) = 0.000000; -NODES[6136](VELOCITY_Z,0) = 0.000000; -NODES[6145](VELOCITY_X,0) = 0.000000; -NODES[6145](VELOCITY_Y,0) = 0.000000; -NODES[6145](VELOCITY_Z,0) = 0.000000; -NODES[6154](VELOCITY_X,0) = 0.000000; -NODES[6154](VELOCITY_Y,0) = 0.000000; -NODES[6154](VELOCITY_Z,0) = 0.000000; -NODES[6155](VELOCITY_X,0) = 0.000000; -NODES[6155](VELOCITY_Y,0) = 0.000000; -NODES[6155](VELOCITY_Z,0) = 0.000000; -NODES[6175](VELOCITY_X,0) = 0.000000; -NODES[6175](VELOCITY_Y,0) = 0.000000; -NODES[6175](VELOCITY_Z,0) = 0.000000; -NODES[6176](VELOCITY_X,0) = 0.000000; -NODES[6176](VELOCITY_Y,0) = 0.000000; -NODES[6176](VELOCITY_Z,0) = 0.000000; -NODES[6195](VELOCITY_X,0) = 0.000000; -NODES[6195](VELOCITY_Y,0) = 0.000000; -NODES[6195](VELOCITY_Z,0) = 0.000000; -NODES[6205](VELOCITY_X,0) = 0.000000; -NODES[6205](VELOCITY_Y,0) = 0.000000; -NODES[6205](VELOCITY_Z,0) = 0.000000; -NODES[6209](VELOCITY_X,0) = 0.000000; -NODES[6209](VELOCITY_Y,0) = 0.000000; -NODES[6209](VELOCITY_Z,0) = 0.000000; -NODES[6241](VELOCITY_X,0) = 0.000000; -NODES[6241](VELOCITY_Y,0) = 0.000000; -NODES[6241](VELOCITY_Z,0) = 0.000000; -NODES[6242](VELOCITY_X,0) = 0.000000; -NODES[6242](VELOCITY_Y,0) = 0.000000; -NODES[6242](VELOCITY_Z,0) = 0.000000; -NODES[6246](VELOCITY_X,0) = 0.000000; -NODES[6246](VELOCITY_Y,0) = 0.000000; -NODES[6246](VELOCITY_Z,0) = 0.000000; -NODES[6252](VELOCITY_X,0) = 0.000000; -NODES[6252](VELOCITY_Y,0) = 0.000000; -NODES[6252](VELOCITY_Z,0) = 0.000000; -NODES[6267](VELOCITY_X,0) = 0.000000; -NODES[6267](VELOCITY_Y,0) = 0.000000; -NODES[6267](VELOCITY_Z,0) = 0.000000; -NODES[6275](VELOCITY_X,0) = 0.000000; -NODES[6275](VELOCITY_Y,0) = 0.000000; -NODES[6275](VELOCITY_Z,0) = 0.000000; -NODES[6276](VELOCITY_X,0) = 0.000000; -NODES[6276](VELOCITY_Y,0) = 0.000000; -NODES[6276](VELOCITY_Z,0) = 0.000000; -NODES[6279](VELOCITY_X,0) = 0.000000; -NODES[6279](VELOCITY_Y,0) = 0.000000; -NODES[6279](VELOCITY_Z,0) = 0.000000; -NODES[6280](VELOCITY_X,0) = 0.000000; -NODES[6280](VELOCITY_Y,0) = 0.000000; -NODES[6280](VELOCITY_Z,0) = 0.000000; -NODES[6288](VELOCITY_X,0) = 0.000000; -NODES[6288](VELOCITY_Y,0) = 0.000000; -NODES[6288](VELOCITY_Z,0) = 0.000000; -NODES[6289](VELOCITY_X,0) = 0.000000; -NODES[6289](VELOCITY_Y,0) = 0.000000; -NODES[6289](VELOCITY_Z,0) = 0.000000; -NODES[6290](VELOCITY_X,0) = 0.000000; -NODES[6290](VELOCITY_Y,0) = 0.000000; -NODES[6290](VELOCITY_Z,0) = 0.000000; -NODES[6291](VELOCITY_X,0) = 0.000000; -NODES[6291](VELOCITY_Y,0) = 0.000000; -NODES[6291](VELOCITY_Z,0) = 0.000000; -NODES[6293](VELOCITY_X,0) = 0.000000; -NODES[6293](VELOCITY_Y,0) = 0.000000; -NODES[6293](VELOCITY_Z,0) = 0.000000; -NODES[6309](VELOCITY_X,0) = 0.000000; -NODES[6309](VELOCITY_Y,0) = 0.000000; -NODES[6309](VELOCITY_Z,0) = 0.000000; -NODES[6310](VELOCITY_X,0) = 0.000000; -NODES[6310](VELOCITY_Y,0) = 0.000000; -NODES[6310](VELOCITY_Z,0) = 0.000000; -NODES[6322](VELOCITY_X,0) = 0.000000; -NODES[6322](VELOCITY_Y,0) = 0.000000; -NODES[6322](VELOCITY_Z,0) = 0.000000; -NODES[6323](VELOCITY_X,0) = 0.000000; -NODES[6323](VELOCITY_Y,0) = 0.000000; -NODES[6323](VELOCITY_Z,0) = 0.000000; -NODES[6324](VELOCITY_X,0) = 0.000000; -NODES[6324](VELOCITY_Y,0) = 0.000000; -NODES[6324](VELOCITY_Z,0) = 0.000000; -NODES[6325](VELOCITY_X,0) = 0.000000; -NODES[6325](VELOCITY_Y,0) = 0.000000; -NODES[6325](VELOCITY_Z,0) = 0.000000; -NODES[6326](VELOCITY_X,0) = 0.000000; -NODES[6326](VELOCITY_Y,0) = 0.000000; -NODES[6326](VELOCITY_Z,0) = 0.000000; -NODES[6327](VELOCITY_X,0) = 0.000000; -NODES[6327](VELOCITY_Y,0) = 0.000000; -NODES[6327](VELOCITY_Z,0) = 0.000000; -NODES[6328](VELOCITY_X,0) = 0.000000; -NODES[6328](VELOCITY_Y,0) = 0.000000; -NODES[6328](VELOCITY_Z,0) = 0.000000; -NODES[6343](VELOCITY_X,0) = 0.000000; -NODES[6343](VELOCITY_Y,0) = 0.000000; -NODES[6343](VELOCITY_Z,0) = 0.000000; -NODES[6344](VELOCITY_X,0) = 0.000000; -NODES[6344](VELOCITY_Y,0) = 0.000000; -NODES[6344](VELOCITY_Z,0) = 0.000000; -NODES[6356](VELOCITY_X,0) = 0.000000; -NODES[6356](VELOCITY_Y,0) = 0.000000; -NODES[6356](VELOCITY_Z,0) = 0.000000; -NODES[6357](VELOCITY_X,0) = 0.000000; -NODES[6357](VELOCITY_Y,0) = 0.000000; -NODES[6357](VELOCITY_Z,0) = 0.000000; -NODES[6358](VELOCITY_X,0) = 0.000000; -NODES[6358](VELOCITY_Y,0) = 0.000000; -NODES[6358](VELOCITY_Z,0) = 0.000000; -NODES[6359](VELOCITY_X,0) = 0.000000; -NODES[6359](VELOCITY_Y,0) = 0.000000; -NODES[6359](VELOCITY_Z,0) = 0.000000; -NODES[6377](VELOCITY_X,0) = 0.000000; -NODES[6377](VELOCITY_Y,0) = 0.000000; -NODES[6377](VELOCITY_Z,0) = 0.000000; -NODES[6378](VELOCITY_X,0) = 0.000000; -NODES[6378](VELOCITY_Y,0) = 0.000000; -NODES[6378](VELOCITY_Z,0) = 0.000000; -NODES[6379](VELOCITY_X,0) = 0.000000; -NODES[6379](VELOCITY_Y,0) = 0.000000; -NODES[6379](VELOCITY_Z,0) = 0.000000; -NODES[6380](VELOCITY_X,0) = 0.000000; -NODES[6380](VELOCITY_Y,0) = 0.000000; -NODES[6380](VELOCITY_Z,0) = 0.000000; -NODES[6381](VELOCITY_X,0) = 0.000000; -NODES[6381](VELOCITY_Y,0) = 0.000000; -NODES[6381](VELOCITY_Z,0) = 0.000000; -NODES[6382](VELOCITY_X,0) = 0.000000; -NODES[6382](VELOCITY_Y,0) = 0.000000; -NODES[6382](VELOCITY_Z,0) = 0.000000; -NODES[6384](VELOCITY_X,0) = 0.000000; -NODES[6384](VELOCITY_Y,0) = 0.000000; -NODES[6384](VELOCITY_Z,0) = 0.000000; -NODES[6385](VELOCITY_X,0) = 0.000000; -NODES[6385](VELOCITY_Y,0) = 0.000000; -NODES[6385](VELOCITY_Z,0) = 0.000000; -NODES[6392](VELOCITY_X,0) = 0.000000; -NODES[6392](VELOCITY_Y,0) = 0.000000; -NODES[6392](VELOCITY_Z,0) = 0.000000; -NODES[6398](VELOCITY_X,0) = 0.000000; -NODES[6398](VELOCITY_Y,0) = 0.000000; -NODES[6398](VELOCITY_Z,0) = 0.000000; -NODES[6400](VELOCITY_X,0) = 0.000000; -NODES[6400](VELOCITY_Y,0) = 0.000000; -NODES[6400](VELOCITY_Z,0) = 0.000000; -NODES[6408](VELOCITY_X,0) = 0.000000; -NODES[6408](VELOCITY_Y,0) = 0.000000; -NODES[6408](VELOCITY_Z,0) = 0.000000; -NODES[6409](VELOCITY_X,0) = 0.000000; -NODES[6409](VELOCITY_Y,0) = 0.000000; -NODES[6409](VELOCITY_Z,0) = 0.000000; -NODES[6410](VELOCITY_X,0) = 0.000000; -NODES[6410](VELOCITY_Y,0) = 0.000000; -NODES[6410](VELOCITY_Z,0) = 0.000000; -NODES[6420](VELOCITY_X,0) = 0.000000; -NODES[6420](VELOCITY_Y,0) = 0.000000; -NODES[6420](VELOCITY_Z,0) = 0.000000; -NODES[6422](VELOCITY_X,0) = 0.000000; -NODES[6422](VELOCITY_Y,0) = 0.000000; -NODES[6422](VELOCITY_Z,0) = 0.000000; -NODES[6423](VELOCITY_X,0) = 0.000000; -NODES[6423](VELOCITY_Y,0) = 0.000000; -NODES[6423](VELOCITY_Z,0) = 0.000000; -NODES[6424](VELOCITY_X,0) = 0.000000; -NODES[6424](VELOCITY_Y,0) = 0.000000; -NODES[6424](VELOCITY_Z,0) = 0.000000; -NODES[6425](VELOCITY_X,0) = 0.000000; -NODES[6425](VELOCITY_Y,0) = 0.000000; -NODES[6425](VELOCITY_Z,0) = 0.000000; -NODES[6426](VELOCITY_X,0) = 0.000000; -NODES[6426](VELOCITY_Y,0) = 0.000000; -NODES[6426](VELOCITY_Z,0) = 0.000000; -NODES[6434](VELOCITY_X,0) = 0.000000; -NODES[6434](VELOCITY_Y,0) = 0.000000; -NODES[6434](VELOCITY_Z,0) = 0.000000; -NODES[6435](VELOCITY_X,0) = 0.000000; -NODES[6435](VELOCITY_Y,0) = 0.000000; -NODES[6435](VELOCITY_Z,0) = 0.000000; -NODES[6436](VELOCITY_X,0) = 0.000000; -NODES[6436](VELOCITY_Y,0) = 0.000000; -NODES[6436](VELOCITY_Z,0) = 0.000000; -NODES[6439](VELOCITY_X,0) = 0.000000; -NODES[6439](VELOCITY_Y,0) = 0.000000; -NODES[6439](VELOCITY_Z,0) = 0.000000; -NODES[6440](VELOCITY_X,0) = 0.000000; -NODES[6440](VELOCITY_Y,0) = 0.000000; -NODES[6440](VELOCITY_Z,0) = 0.000000; -NODES[6451](VELOCITY_X,0) = 0.000000; -NODES[6451](VELOCITY_Y,0) = 0.000000; -NODES[6451](VELOCITY_Z,0) = 0.000000; -NODES[6452](VELOCITY_X,0) = 0.000000; -NODES[6452](VELOCITY_Y,0) = 0.000000; -NODES[6452](VELOCITY_Z,0) = 0.000000; -NODES[6453](VELOCITY_X,0) = 0.000000; -NODES[6453](VELOCITY_Y,0) = 0.000000; -NODES[6453](VELOCITY_Z,0) = 0.000000; -NODES[6454](VELOCITY_X,0) = 0.000000; -NODES[6454](VELOCITY_Y,0) = 0.000000; -NODES[6454](VELOCITY_Z,0) = 0.000000; -NODES[6455](VELOCITY_X,0) = 0.000000; -NODES[6455](VELOCITY_Y,0) = 0.000000; -NODES[6455](VELOCITY_Z,0) = 0.000000; -NODES[6469](VELOCITY_X,0) = 0.000000; -NODES[6469](VELOCITY_Y,0) = 0.000000; -NODES[6469](VELOCITY_Z,0) = 0.000000; -NODES[6470](VELOCITY_X,0) = 0.000000; -NODES[6470](VELOCITY_Y,0) = 0.000000; -NODES[6470](VELOCITY_Z,0) = 0.000000; -NODES[6473](VELOCITY_X,0) = 0.000000; -NODES[6473](VELOCITY_Y,0) = 0.000000; -NODES[6473](VELOCITY_Z,0) = 0.000000; -NODES[6474](VELOCITY_X,0) = 0.000000; -NODES[6474](VELOCITY_Y,0) = 0.000000; -NODES[6474](VELOCITY_Z,0) = 0.000000; -NODES[6478](VELOCITY_X,0) = 0.000000; -NODES[6478](VELOCITY_Y,0) = 0.000000; -NODES[6478](VELOCITY_Z,0) = 0.000000; -NODES[6482](VELOCITY_X,0) = 0.000000; -NODES[6482](VELOCITY_Y,0) = 0.000000; -NODES[6482](VELOCITY_Z,0) = 0.000000; -NODES[6484](VELOCITY_X,0) = 0.000000; -NODES[6484](VELOCITY_Y,0) = 0.000000; -NODES[6484](VELOCITY_Z,0) = 0.000000; -NODES[6485](VELOCITY_X,0) = 0.000000; -NODES[6485](VELOCITY_Y,0) = 0.000000; -NODES[6485](VELOCITY_Z,0) = 0.000000; -NODES[6486](VELOCITY_X,0) = 0.000000; -NODES[6486](VELOCITY_Y,0) = 0.000000; -NODES[6486](VELOCITY_Z,0) = 0.000000; -NODES[6487](VELOCITY_X,0) = 0.000000; -NODES[6487](VELOCITY_Y,0) = 0.000000; -NODES[6487](VELOCITY_Z,0) = 0.000000; -NODES[6499](VELOCITY_X,0) = 0.000000; -NODES[6499](VELOCITY_Y,0) = 0.000000; -NODES[6499](VELOCITY_Z,0) = 0.000000; -NODES[6502](VELOCITY_X,0) = 0.000000; -NODES[6502](VELOCITY_Y,0) = 0.000000; -NODES[6502](VELOCITY_Z,0) = 0.000000; -NODES[6506](VELOCITY_X,0) = 0.000000; -NODES[6506](VELOCITY_Y,0) = 0.000000; -NODES[6506](VELOCITY_Z,0) = 0.000000; -NODES[6507](VELOCITY_X,0) = 0.000000; -NODES[6507](VELOCITY_Y,0) = 0.000000; -NODES[6507](VELOCITY_Z,0) = 0.000000; -NODES[6508](VELOCITY_X,0) = 0.000000; -NODES[6508](VELOCITY_Y,0) = 0.000000; -NODES[6508](VELOCITY_Z,0) = 0.000000; -NODES[6511](VELOCITY_X,0) = 0.000000; -NODES[6511](VELOCITY_Y,0) = 0.000000; -NODES[6511](VELOCITY_Z,0) = 0.000000; -NODES[6529](VELOCITY_X,0) = 0.000000; -NODES[6529](VELOCITY_Y,0) = 0.000000; -NODES[6529](VELOCITY_Z,0) = 0.000000; -NODES[6544](VELOCITY_X,0) = 0.000000; -NODES[6544](VELOCITY_Y,0) = 0.000000; -NODES[6544](VELOCITY_Z,0) = 0.000000; -NODES[6545](VELOCITY_X,0) = 0.000000; -NODES[6545](VELOCITY_Y,0) = 0.000000; -NODES[6545](VELOCITY_Z,0) = 0.000000; -NODES[6546](VELOCITY_X,0) = 0.000000; -NODES[6546](VELOCITY_Y,0) = 0.000000; -NODES[6546](VELOCITY_Z,0) = 0.000000; -NODES[6547](VELOCITY_X,0) = 0.000000; -NODES[6547](VELOCITY_Y,0) = 0.000000; -NODES[6547](VELOCITY_Z,0) = 0.000000; -NODES[6548](VELOCITY_X,0) = 0.000000; -NODES[6548](VELOCITY_Y,0) = 0.000000; -NODES[6548](VELOCITY_Z,0) = 0.000000; -NODES[6549](VELOCITY_X,0) = 0.000000; -NODES[6549](VELOCITY_Y,0) = 0.000000; -NODES[6549](VELOCITY_Z,0) = 0.000000; -NODES[6550](VELOCITY_X,0) = 0.000000; -NODES[6550](VELOCITY_Y,0) = 0.000000; -NODES[6550](VELOCITY_Z,0) = 0.000000; -NODES[6561](VELOCITY_X,0) = 0.000000; -NODES[6561](VELOCITY_Y,0) = 0.000000; -NODES[6561](VELOCITY_Z,0) = 0.000000; -NODES[6569](VELOCITY_X,0) = 0.000000; -NODES[6569](VELOCITY_Y,0) = 0.000000; -NODES[6569](VELOCITY_Z,0) = 0.000000; -NODES[6570](VELOCITY_X,0) = 0.000000; -NODES[6570](VELOCITY_Y,0) = 0.000000; -NODES[6570](VELOCITY_Z,0) = 0.000000; -NODES[6573](VELOCITY_X,0) = 0.000000; -NODES[6573](VELOCITY_Y,0) = 0.000000; -NODES[6573](VELOCITY_Z,0) = 0.000000; -NODES[6577](VELOCITY_X,0) = 0.000000; -NODES[6577](VELOCITY_Y,0) = 0.000000; -NODES[6577](VELOCITY_Z,0) = 0.000000; -NODES[6578](VELOCITY_X,0) = 0.000000; -NODES[6578](VELOCITY_Y,0) = 0.000000; -NODES[6578](VELOCITY_Z,0) = 0.000000; -NODES[6579](VELOCITY_X,0) = 0.000000; -NODES[6579](VELOCITY_Y,0) = 0.000000; -NODES[6579](VELOCITY_Z,0) = 0.000000; -NODES[6582](VELOCITY_X,0) = 0.000000; -NODES[6582](VELOCITY_Y,0) = 0.000000; -NODES[6582](VELOCITY_Z,0) = 0.000000; -NODES[6593](VELOCITY_X,0) = 0.000000; -NODES[6593](VELOCITY_Y,0) = 0.000000; -NODES[6593](VELOCITY_Z,0) = 0.000000; -NODES[6594](VELOCITY_X,0) = 0.000000; -NODES[6594](VELOCITY_Y,0) = 0.000000; -NODES[6594](VELOCITY_Z,0) = 0.000000; -NODES[6595](VELOCITY_X,0) = 0.000000; -NODES[6595](VELOCITY_Y,0) = 0.000000; -NODES[6595](VELOCITY_Z,0) = 0.000000; -NODES[6596](VELOCITY_X,0) = 0.000000; -NODES[6596](VELOCITY_Y,0) = 0.000000; -NODES[6596](VELOCITY_Z,0) = 0.000000; -NODES[6597](VELOCITY_X,0) = 0.000000; -NODES[6597](VELOCITY_Y,0) = 0.000000; -NODES[6597](VELOCITY_Z,0) = 0.000000; -NODES[6598](VELOCITY_X,0) = 0.000000; -NODES[6598](VELOCITY_Y,0) = 0.000000; -NODES[6598](VELOCITY_Z,0) = 0.000000; -NODES[6603](VELOCITY_X,0) = 0.000000; -NODES[6603](VELOCITY_Y,0) = 0.000000; -NODES[6603](VELOCITY_Z,0) = 0.000000; -NODES[6607](VELOCITY_X,0) = 0.000000; -NODES[6607](VELOCITY_Y,0) = 0.000000; -NODES[6607](VELOCITY_Z,0) = 0.000000; -NODES[6609](VELOCITY_X,0) = 0.000000; -NODES[6609](VELOCITY_Y,0) = 0.000000; -NODES[6609](VELOCITY_Z,0) = 0.000000; -NODES[6610](VELOCITY_X,0) = 0.000000; -NODES[6610](VELOCITY_Y,0) = 0.000000; -NODES[6610](VELOCITY_Z,0) = 0.000000; -NODES[6620](VELOCITY_X,0) = 0.000000; -NODES[6620](VELOCITY_Y,0) = 0.000000; -NODES[6620](VELOCITY_Z,0) = 0.000000; -NODES[6621](VELOCITY_X,0) = 0.000000; -NODES[6621](VELOCITY_Y,0) = 0.000000; -NODES[6621](VELOCITY_Z,0) = 0.000000; -NODES[6622](VELOCITY_X,0) = 0.000000; -NODES[6622](VELOCITY_Y,0) = 0.000000; -NODES[6622](VELOCITY_Z,0) = 0.000000; -NODES[6623](VELOCITY_X,0) = 0.000000; -NODES[6623](VELOCITY_Y,0) = 0.000000; -NODES[6623](VELOCITY_Z,0) = 0.000000; -NODES[6632](VELOCITY_X,0) = 0.000000; -NODES[6632](VELOCITY_Y,0) = 0.000000; -NODES[6632](VELOCITY_Z,0) = 0.000000; -NODES[6635](VELOCITY_X,0) = 0.000000; -NODES[6635](VELOCITY_Y,0) = 0.000000; -NODES[6635](VELOCITY_Z,0) = 0.000000; -NODES[6640](VELOCITY_X,0) = 0.000000; -NODES[6640](VELOCITY_Y,0) = 0.000000; -NODES[6640](VELOCITY_Z,0) = 0.000000; -NODES[6648](VELOCITY_X,0) = 0.000000; -NODES[6648](VELOCITY_Y,0) = 0.000000; -NODES[6648](VELOCITY_Z,0) = 0.000000; -NODES[6649](VELOCITY_X,0) = 0.000000; -NODES[6649](VELOCITY_Y,0) = 0.000000; -NODES[6649](VELOCITY_Z,0) = 0.000000; -NODES[6651](VELOCITY_X,0) = 0.000000; -NODES[6651](VELOCITY_Y,0) = 0.000000; -NODES[6651](VELOCITY_Z,0) = 0.000000; -NODES[6658](VELOCITY_X,0) = 0.000000; -NODES[6658](VELOCITY_Y,0) = 0.000000; -NODES[6658](VELOCITY_Z,0) = 0.000000; -NODES[6663](VELOCITY_X,0) = 0.000000; -NODES[6663](VELOCITY_Y,0) = 0.000000; -NODES[6663](VELOCITY_Z,0) = 0.000000; -NODES[6665](VELOCITY_X,0) = 0.000000; -NODES[6665](VELOCITY_Y,0) = 0.000000; -NODES[6665](VELOCITY_Z,0) = 0.000000; -NODES[6666](VELOCITY_X,0) = 0.000000; -NODES[6666](VELOCITY_Y,0) = 0.000000; -NODES[6666](VELOCITY_Z,0) = 0.000000; -NODES[6673](VELOCITY_X,0) = 0.000000; -NODES[6673](VELOCITY_Y,0) = 0.000000; -NODES[6673](VELOCITY_Z,0) = 0.000000; -NODES[6674](VELOCITY_X,0) = 0.000000; -NODES[6674](VELOCITY_Y,0) = 0.000000; -NODES[6674](VELOCITY_Z,0) = 0.000000; -NODES[6681](VELOCITY_X,0) = 0.000000; -NODES[6681](VELOCITY_Y,0) = 0.000000; -NODES[6681](VELOCITY_Z,0) = 0.000000; -NODES[6683](VELOCITY_X,0) = 0.000000; -NODES[6683](VELOCITY_Y,0) = 0.000000; -NODES[6683](VELOCITY_Z,0) = 0.000000; -NODES[6684](VELOCITY_X,0) = 0.000000; -NODES[6684](VELOCITY_Y,0) = 0.000000; -NODES[6684](VELOCITY_Z,0) = 0.000000; -NODES[6685](VELOCITY_X,0) = 0.000000; -NODES[6685](VELOCITY_Y,0) = 0.000000; -NODES[6685](VELOCITY_Z,0) = 0.000000; -NODES[6686](VELOCITY_X,0) = 0.000000; -NODES[6686](VELOCITY_Y,0) = 0.000000; -NODES[6686](VELOCITY_Z,0) = 0.000000; -NODES[6687](VELOCITY_X,0) = 0.000000; -NODES[6687](VELOCITY_Y,0) = 0.000000; -NODES[6687](VELOCITY_Z,0) = 0.000000; -NODES[6695](VELOCITY_X,0) = 0.000000; -NODES[6695](VELOCITY_Y,0) = 0.000000; -NODES[6695](VELOCITY_Z,0) = 0.000000; -NODES[6699](VELOCITY_X,0) = 0.000000; -NODES[6699](VELOCITY_Y,0) = 0.000000; -NODES[6699](VELOCITY_Z,0) = 0.000000; -NODES[6700](VELOCITY_X,0) = 0.000000; -NODES[6700](VELOCITY_Y,0) = 0.000000; -NODES[6700](VELOCITY_Z,0) = 0.000000; -NODES[6701](VELOCITY_X,0) = 0.000000; -NODES[6701](VELOCITY_Y,0) = 0.000000; -NODES[6701](VELOCITY_Z,0) = 0.000000; -NODES[6702](VELOCITY_X,0) = 0.000000; -NODES[6702](VELOCITY_Y,0) = 0.000000; -NODES[6702](VELOCITY_Z,0) = 0.000000; -NODES[6703](VELOCITY_X,0) = 0.000000; -NODES[6703](VELOCITY_Y,0) = 0.000000; -NODES[6703](VELOCITY_Z,0) = 0.000000; -NODES[6704](VELOCITY_X,0) = 0.000000; -NODES[6704](VELOCITY_Y,0) = 0.000000; -NODES[6704](VELOCITY_Z,0) = 0.000000; -NODES[6705](VELOCITY_X,0) = 0.000000; -NODES[6705](VELOCITY_Y,0) = 0.000000; -NODES[6705](VELOCITY_Z,0) = 0.000000; -NODES[6712](VELOCITY_X,0) = 0.000000; -NODES[6712](VELOCITY_Y,0) = 0.000000; -NODES[6712](VELOCITY_Z,0) = 0.000000; -NODES[6716](VELOCITY_X,0) = 0.000000; -NODES[6716](VELOCITY_Y,0) = 0.000000; -NODES[6716](VELOCITY_Z,0) = 0.000000; -NODES[6717](VELOCITY_X,0) = 0.000000; -NODES[6717](VELOCITY_Y,0) = 0.000000; -NODES[6717](VELOCITY_Z,0) = 0.000000; -NODES[6727](VELOCITY_X,0) = 0.000000; -NODES[6727](VELOCITY_Y,0) = 0.000000; -NODES[6727](VELOCITY_Z,0) = 0.000000; -NODES[6731](VELOCITY_X,0) = 0.000000; -NODES[6731](VELOCITY_Y,0) = 0.000000; -NODES[6731](VELOCITY_Z,0) = 0.000000; -NODES[6732](VELOCITY_X,0) = 0.000000; -NODES[6732](VELOCITY_Y,0) = 0.000000; -NODES[6732](VELOCITY_Z,0) = 0.000000; -NODES[6733](VELOCITY_X,0) = 0.000000; -NODES[6733](VELOCITY_Y,0) = 0.000000; -NODES[6733](VELOCITY_Z,0) = 0.000000; -NODES[6734](VELOCITY_X,0) = 0.000000; -NODES[6734](VELOCITY_Y,0) = 0.000000; -NODES[6734](VELOCITY_Z,0) = 0.000000; -NODES[6735](VELOCITY_X,0) = 0.000000; -NODES[6735](VELOCITY_Y,0) = 0.000000; -NODES[6735](VELOCITY_Z,0) = 0.000000; -NODES[6743](VELOCITY_X,0) = 0.000000; -NODES[6743](VELOCITY_Y,0) = 0.000000; -NODES[6743](VELOCITY_Z,0) = 0.000000; -NODES[6752](VELOCITY_X,0) = 0.000000; -NODES[6752](VELOCITY_Y,0) = 0.000000; -NODES[6752](VELOCITY_Z,0) = 0.000000; -NODES[6753](VELOCITY_X,0) = 0.000000; -NODES[6753](VELOCITY_Y,0) = 0.000000; -NODES[6753](VELOCITY_Z,0) = 0.000000; -NODES[6760](VELOCITY_X,0) = 0.000000; -NODES[6760](VELOCITY_Y,0) = 0.000000; -NODES[6760](VELOCITY_Z,0) = 0.000000; -NODES[6769](VELOCITY_X,0) = 0.000000; -NODES[6769](VELOCITY_Y,0) = 0.000000; -NODES[6769](VELOCITY_Z,0) = 0.000000; -NODES[6774](VELOCITY_X,0) = 0.000000; -NODES[6774](VELOCITY_Y,0) = 0.000000; -NODES[6774](VELOCITY_Z,0) = 0.000000; -NODES[6775](VELOCITY_X,0) = 0.000000; -NODES[6775](VELOCITY_Y,0) = 0.000000; -NODES[6775](VELOCITY_Z,0) = 0.000000; -NODES[6782](VELOCITY_X,0) = 0.000000; -NODES[6782](VELOCITY_Y,0) = 0.000000; -NODES[6782](VELOCITY_Z,0) = 0.000000; -NODES[6783](VELOCITY_X,0) = 0.000000; -NODES[6783](VELOCITY_Y,0) = 0.000000; -NODES[6783](VELOCITY_Z,0) = 0.000000; -NODES[6784](VELOCITY_X,0) = 0.000000; -NODES[6784](VELOCITY_Y,0) = 0.000000; -NODES[6784](VELOCITY_Z,0) = 0.000000; -NODES[6785](VELOCITY_X,0) = 0.000000; -NODES[6785](VELOCITY_Y,0) = 0.000000; -NODES[6785](VELOCITY_Z,0) = 0.000000; -NODES[6786](VELOCITY_X,0) = 0.000000; -NODES[6786](VELOCITY_Y,0) = 0.000000; -NODES[6786](VELOCITY_Z,0) = 0.000000; -NODES[6787](VELOCITY_X,0) = 0.000000; -NODES[6787](VELOCITY_Y,0) = 0.000000; -NODES[6787](VELOCITY_Z,0) = 0.000000; -NODES[6820](VELOCITY_X,0) = 0.000000; -NODES[6820](VELOCITY_Y,0) = 0.000000; -NODES[6820](VELOCITY_Z,0) = 0.000000; -NODES[6827](VELOCITY_X,0) = 0.000000; -NODES[6827](VELOCITY_Y,0) = 0.000000; -NODES[6827](VELOCITY_Z,0) = 0.000000; -NODES[6831](VELOCITY_X,0) = 0.000000; -NODES[6831](VELOCITY_Y,0) = 0.000000; -NODES[6831](VELOCITY_Z,0) = 0.000000; -NODES[6833](VELOCITY_X,0) = 0.000000; -NODES[6833](VELOCITY_Y,0) = 0.000000; -NODES[6833](VELOCITY_Z,0) = 0.000000; -NODES[6834](VELOCITY_X,0) = 0.000000; -NODES[6834](VELOCITY_Y,0) = 0.000000; -NODES[6834](VELOCITY_Z,0) = 0.000000; -NODES[6837](VELOCITY_X,0) = 0.000000; -NODES[6837](VELOCITY_Y,0) = 0.000000; -NODES[6837](VELOCITY_Z,0) = 0.000000; -NODES[6840](VELOCITY_X,0) = 0.000000; -NODES[6840](VELOCITY_Y,0) = 0.000000; -NODES[6840](VELOCITY_Z,0) = 0.000000; -NODES[6843](VELOCITY_X,0) = 0.000000; -NODES[6843](VELOCITY_Y,0) = 0.000000; -NODES[6843](VELOCITY_Z,0) = 0.000000; -NODES[6844](VELOCITY_X,0) = 0.000000; -NODES[6844](VELOCITY_Y,0) = 0.000000; -NODES[6844](VELOCITY_Z,0) = 0.000000; -NODES[6845](VELOCITY_X,0) = 0.000000; -NODES[6845](VELOCITY_Y,0) = 0.000000; -NODES[6845](VELOCITY_Z,0) = 0.000000; -NODES[6846](VELOCITY_X,0) = 0.000000; -NODES[6846](VELOCITY_Y,0) = 0.000000; -NODES[6846](VELOCITY_Z,0) = 0.000000; -NODES[6847](VELOCITY_X,0) = 0.000000; -NODES[6847](VELOCITY_Y,0) = 0.000000; -NODES[6847](VELOCITY_Z,0) = 0.000000; -NODES[6848](VELOCITY_X,0) = 0.000000; -NODES[6848](VELOCITY_Y,0) = 0.000000; -NODES[6848](VELOCITY_Z,0) = 0.000000; -NODES[6849](VELOCITY_X,0) = 0.000000; -NODES[6849](VELOCITY_Y,0) = 0.000000; -NODES[6849](VELOCITY_Z,0) = 0.000000; -NODES[6850](VELOCITY_X,0) = 0.000000; -NODES[6850](VELOCITY_Y,0) = 0.000000; -NODES[6850](VELOCITY_Z,0) = 0.000000; -NODES[6851](VELOCITY_X,0) = 0.000000; -NODES[6851](VELOCITY_Y,0) = 0.000000; -NODES[6851](VELOCITY_Z,0) = 0.000000; -NODES[6852](VELOCITY_X,0) = 0.000000; -NODES[6852](VELOCITY_Y,0) = 0.000000; -NODES[6852](VELOCITY_Z,0) = 0.000000; -NODES[6857](VELOCITY_X,0) = 0.000000; -NODES[6857](VELOCITY_Y,0) = 0.000000; -NODES[6857](VELOCITY_Z,0) = 0.000000; -NODES[6858](VELOCITY_X,0) = 0.000000; -NODES[6858](VELOCITY_Y,0) = 0.000000; -NODES[6858](VELOCITY_Z,0) = 0.000000; -NODES[6865](VELOCITY_X,0) = 0.000000; -NODES[6865](VELOCITY_Y,0) = 0.000000; -NODES[6865](VELOCITY_Z,0) = 0.000000; -NODES[6866](VELOCITY_X,0) = 0.000000; -NODES[6866](VELOCITY_Y,0) = 0.000000; -NODES[6866](VELOCITY_Z,0) = 0.000000; -NODES[6870](VELOCITY_X,0) = 0.000000; -NODES[6870](VELOCITY_Y,0) = 0.000000; -NODES[6870](VELOCITY_Z,0) = 0.000000; -NODES[6876](VELOCITY_X,0) = 0.000000; -NODES[6876](VELOCITY_Y,0) = 0.000000; -NODES[6876](VELOCITY_Z,0) = 0.000000; -NODES[6877](VELOCITY_X,0) = 0.000000; -NODES[6877](VELOCITY_Y,0) = 0.000000; -NODES[6877](VELOCITY_Z,0) = 0.000000; -NODES[6880](VELOCITY_X,0) = 0.000000; -NODES[6880](VELOCITY_Y,0) = 0.000000; -NODES[6880](VELOCITY_Z,0) = 0.000000; -NODES[6881](VELOCITY_X,0) = 0.000000; -NODES[6881](VELOCITY_Y,0) = 0.000000; -NODES[6881](VELOCITY_Z,0) = 0.000000; -NODES[6882](VELOCITY_X,0) = 0.000000; -NODES[6882](VELOCITY_Y,0) = 0.000000; -NODES[6882](VELOCITY_Z,0) = 0.000000; -NODES[6883](VELOCITY_X,0) = 0.000000; -NODES[6883](VELOCITY_Y,0) = 0.000000; -NODES[6883](VELOCITY_Z,0) = 0.000000; -NODES[6884](VELOCITY_X,0) = 0.000000; -NODES[6884](VELOCITY_Y,0) = 0.000000; -NODES[6884](VELOCITY_Z,0) = 0.000000; -NODES[6903](VELOCITY_X,0) = 0.000000; -NODES[6903](VELOCITY_Y,0) = 0.000000; -NODES[6903](VELOCITY_Z,0) = 0.000000; -NODES[6907](VELOCITY_X,0) = 0.000000; -NODES[6907](VELOCITY_Y,0) = 0.000000; -NODES[6907](VELOCITY_Z,0) = 0.000000; -NODES[6913](VELOCITY_X,0) = 0.000000; -NODES[6913](VELOCITY_Y,0) = 0.000000; -NODES[6913](VELOCITY_Z,0) = 0.000000; -NODES[6922](VELOCITY_X,0) = 0.000000; -NODES[6922](VELOCITY_Y,0) = 0.000000; -NODES[6922](VELOCITY_Z,0) = 0.000000; -NODES[6929](VELOCITY_X,0) = 0.000000; -NODES[6929](VELOCITY_Y,0) = 0.000000; -NODES[6929](VELOCITY_Z,0) = 0.000000; -NODES[6930](VELOCITY_X,0) = 0.000000; -NODES[6930](VELOCITY_Y,0) = 0.000000; -NODES[6930](VELOCITY_Z,0) = 0.000000; -NODES[6931](VELOCITY_X,0) = 0.000000; -NODES[6931](VELOCITY_Y,0) = 0.000000; -NODES[6931](VELOCITY_Z,0) = 0.000000; -NODES[6932](VELOCITY_X,0) = 0.000000; -NODES[6932](VELOCITY_Y,0) = 0.000000; -NODES[6932](VELOCITY_Z,0) = 0.000000; -NODES[6948](VELOCITY_X,0) = 0.000000; -NODES[6948](VELOCITY_Y,0) = 0.000000; -NODES[6948](VELOCITY_Z,0) = 0.000000; -NODES[6961](VELOCITY_X,0) = 0.000000; -NODES[6961](VELOCITY_Y,0) = 0.000000; -NODES[6961](VELOCITY_Z,0) = 0.000000; -NODES[6962](VELOCITY_X,0) = 0.000000; -NODES[6962](VELOCITY_Y,0) = 0.000000; -NODES[6962](VELOCITY_Z,0) = 0.000000; -NODES[6963](VELOCITY_X,0) = 0.000000; -NODES[6963](VELOCITY_Y,0) = 0.000000; -NODES[6963](VELOCITY_Z,0) = 0.000000; -NODES[6972](VELOCITY_X,0) = 0.000000; -NODES[6972](VELOCITY_Y,0) = 0.000000; -NODES[6972](VELOCITY_Z,0) = 0.000000; -NODES[6973](VELOCITY_X,0) = 0.000000; -NODES[6973](VELOCITY_Y,0) = 0.000000; -NODES[6973](VELOCITY_Z,0) = 0.000000; -NODES[6974](VELOCITY_X,0) = 0.000000; -NODES[6974](VELOCITY_Y,0) = 0.000000; -NODES[6974](VELOCITY_Z,0) = 0.000000; -NODES[6975](VELOCITY_X,0) = 0.000000; -NODES[6975](VELOCITY_Y,0) = 0.000000; -NODES[6975](VELOCITY_Z,0) = 0.000000; -NODES[6983](VELOCITY_X,0) = 0.000000; -NODES[6983](VELOCITY_Y,0) = 0.000000; -NODES[6983](VELOCITY_Z,0) = 0.000000; -NODES[6990](VELOCITY_X,0) = 0.000000; -NODES[6990](VELOCITY_Y,0) = 0.000000; -NODES[6990](VELOCITY_Z,0) = 0.000000; -NODES[6996](VELOCITY_X,0) = 0.000000; -NODES[6996](VELOCITY_Y,0) = 0.000000; -NODES[6996](VELOCITY_Z,0) = 0.000000; -NODES[7001](VELOCITY_X,0) = 0.000000; -NODES[7001](VELOCITY_Y,0) = 0.000000; -NODES[7001](VELOCITY_Z,0) = 0.000000; -NODES[7002](VELOCITY_X,0) = 0.000000; -NODES[7002](VELOCITY_Y,0) = 0.000000; -NODES[7002](VELOCITY_Z,0) = 0.000000; -NODES[7003](VELOCITY_X,0) = 0.000000; -NODES[7003](VELOCITY_Y,0) = 0.000000; -NODES[7003](VELOCITY_Z,0) = 0.000000; -NODES[7004](VELOCITY_X,0) = 0.000000; -NODES[7004](VELOCITY_Y,0) = 0.000000; -NODES[7004](VELOCITY_Z,0) = 0.000000; -NODES[7006](VELOCITY_X,0) = 0.000000; -NODES[7006](VELOCITY_Y,0) = 0.000000; -NODES[7006](VELOCITY_Z,0) = 0.000000; -NODES[7008](VELOCITY_X,0) = 0.000000; -NODES[7008](VELOCITY_Y,0) = 0.000000; -NODES[7008](VELOCITY_Z,0) = 0.000000; -NODES[7009](VELOCITY_X,0) = 0.000000; -NODES[7009](VELOCITY_Y,0) = 0.000000; -NODES[7009](VELOCITY_Z,0) = 0.000000; -NODES[7012](VELOCITY_X,0) = 0.000000; -NODES[7012](VELOCITY_Y,0) = 0.000000; -NODES[7012](VELOCITY_Z,0) = 0.000000; -NODES[7017](VELOCITY_X,0) = 0.000000; -NODES[7017](VELOCITY_Y,0) = 0.000000; -NODES[7017](VELOCITY_Z,0) = 0.000000; -NODES[7018](VELOCITY_X,0) = 0.000000; -NODES[7018](VELOCITY_Y,0) = 0.000000; -NODES[7018](VELOCITY_Z,0) = 0.000000; -NODES[7019](VELOCITY_X,0) = 0.000000; -NODES[7019](VELOCITY_Y,0) = 0.000000; -NODES[7019](VELOCITY_Z,0) = 0.000000; -NODES[7020](VELOCITY_X,0) = 0.000000; -NODES[7020](VELOCITY_Y,0) = 0.000000; -NODES[7020](VELOCITY_Z,0) = 0.000000; -NODES[7021](VELOCITY_X,0) = 0.000000; -NODES[7021](VELOCITY_Y,0) = 0.000000; -NODES[7021](VELOCITY_Z,0) = 0.000000; -NODES[7029](VELOCITY_X,0) = 0.000000; -NODES[7029](VELOCITY_Y,0) = 0.000000; -NODES[7029](VELOCITY_Z,0) = 0.000000; -NODES[7033](VELOCITY_X,0) = 0.000000; -NODES[7033](VELOCITY_Y,0) = 0.000000; -NODES[7033](VELOCITY_Z,0) = 0.000000; -NODES[7039](VELOCITY_X,0) = 0.000000; -NODES[7039](VELOCITY_Y,0) = 0.000000; -NODES[7039](VELOCITY_Z,0) = 0.000000; -NODES[7044](VELOCITY_X,0) = 0.000000; -NODES[7044](VELOCITY_Y,0) = 0.000000; -NODES[7044](VELOCITY_Z,0) = 0.000000; -NODES[7045](VELOCITY_X,0) = 0.000000; -NODES[7045](VELOCITY_Y,0) = 0.000000; -NODES[7045](VELOCITY_Z,0) = 0.000000; -NODES[7046](VELOCITY_X,0) = 0.000000; -NODES[7046](VELOCITY_Y,0) = 0.000000; -NODES[7046](VELOCITY_Z,0) = 0.000000; -NODES[7047](VELOCITY_X,0) = 0.000000; -NODES[7047](VELOCITY_Y,0) = 0.000000; -NODES[7047](VELOCITY_Z,0) = 0.000000; -NODES[7048](VELOCITY_X,0) = 0.000000; -NODES[7048](VELOCITY_Y,0) = 0.000000; -NODES[7048](VELOCITY_Z,0) = 0.000000; -NODES[7049](VELOCITY_X,0) = 0.000000; -NODES[7049](VELOCITY_Y,0) = 0.000000; -NODES[7049](VELOCITY_Z,0) = 0.000000; -NODES[7060](VELOCITY_X,0) = 0.000000; -NODES[7060](VELOCITY_Y,0) = 0.000000; -NODES[7060](VELOCITY_Z,0) = 0.000000; -NODES[7066](VELOCITY_X,0) = 0.000000; -NODES[7066](VELOCITY_Y,0) = 0.000000; -NODES[7066](VELOCITY_Z,0) = 0.000000; -NODES[7070](VELOCITY_X,0) = 0.000000; -NODES[7070](VELOCITY_Y,0) = 0.000000; -NODES[7070](VELOCITY_Z,0) = 0.000000; -NODES[7075](VELOCITY_X,0) = 0.000000; -NODES[7075](VELOCITY_Y,0) = 0.000000; -NODES[7075](VELOCITY_Z,0) = 0.000000; -NODES[7080](VELOCITY_X,0) = 0.000000; -NODES[7080](VELOCITY_Y,0) = 0.000000; -NODES[7080](VELOCITY_Z,0) = 0.000000; -NODES[7083](VELOCITY_X,0) = 0.000000; -NODES[7083](VELOCITY_Y,0) = 0.000000; -NODES[7083](VELOCITY_Z,0) = 0.000000; -NODES[7084](VELOCITY_X,0) = 0.000000; -NODES[7084](VELOCITY_Y,0) = 0.000000; -NODES[7084](VELOCITY_Z,0) = 0.000000; -NODES[7099](VELOCITY_X,0) = 0.000000; -NODES[7099](VELOCITY_Y,0) = 0.000000; -NODES[7099](VELOCITY_Z,0) = 0.000000; -NODES[7100](VELOCITY_X,0) = 0.000000; -NODES[7100](VELOCITY_Y,0) = 0.000000; -NODES[7100](VELOCITY_Z,0) = 0.000000; -NODES[7101](VELOCITY_X,0) = 0.000000; -NODES[7101](VELOCITY_Y,0) = 0.000000; -NODES[7101](VELOCITY_Z,0) = 0.000000; -NODES[7102](VELOCITY_X,0) = 0.000000; -NODES[7102](VELOCITY_Y,0) = 0.000000; -NODES[7102](VELOCITY_Z,0) = 0.000000; -NODES[7103](VELOCITY_X,0) = 0.000000; -NODES[7103](VELOCITY_Y,0) = 0.000000; -NODES[7103](VELOCITY_Z,0) = 0.000000; -NODES[7108](VELOCITY_X,0) = 0.000000; -NODES[7108](VELOCITY_Y,0) = 0.000000; -NODES[7108](VELOCITY_Z,0) = 0.000000; -NODES[7125](VELOCITY_X,0) = 0.000000; -NODES[7125](VELOCITY_Y,0) = 0.000000; -NODES[7125](VELOCITY_Z,0) = 0.000000; -NODES[7131](VELOCITY_X,0) = 0.000000; -NODES[7131](VELOCITY_Y,0) = 0.000000; -NODES[7131](VELOCITY_Z,0) = 0.000000; -NODES[7136](VELOCITY_X,0) = 0.000000; -NODES[7136](VELOCITY_Y,0) = 0.000000; -NODES[7136](VELOCITY_Z,0) = 0.000000; -NODES[7137](VELOCITY_X,0) = 0.000000; -NODES[7137](VELOCITY_Y,0) = 0.000000; -NODES[7137](VELOCITY_Z,0) = 0.000000; -NODES[7138](VELOCITY_X,0) = 0.000000; -NODES[7138](VELOCITY_Y,0) = 0.000000; -NODES[7138](VELOCITY_Z,0) = 0.000000; -NODES[7144](VELOCITY_X,0) = 0.000000; -NODES[7144](VELOCITY_Y,0) = 0.000000; -NODES[7144](VELOCITY_Z,0) = 0.000000; -NODES[7145](VELOCITY_X,0) = 0.000000; -NODES[7145](VELOCITY_Y,0) = 0.000000; -NODES[7145](VELOCITY_Z,0) = 0.000000; -NODES[7160](VELOCITY_X,0) = 0.000000; -NODES[7160](VELOCITY_Y,0) = 0.000000; -NODES[7160](VELOCITY_Z,0) = 0.000000; -NODES[7162](VELOCITY_X,0) = 0.000000; -NODES[7162](VELOCITY_Y,0) = 0.000000; -NODES[7162](VELOCITY_Z,0) = 0.000000; -NODES[7168](VELOCITY_X,0) = 0.000000; -NODES[7168](VELOCITY_Y,0) = 0.000000; -NODES[7168](VELOCITY_Z,0) = 0.000000; -NODES[7173](VELOCITY_X,0) = 0.000000; -NODES[7173](VELOCITY_Y,0) = 0.000000; -NODES[7173](VELOCITY_Z,0) = 0.000000; -NODES[7174](VELOCITY_X,0) = 0.000000; -NODES[7174](VELOCITY_Y,0) = 0.000000; -NODES[7174](VELOCITY_Z,0) = 0.000000; -NODES[7175](VELOCITY_X,0) = 0.000000; -NODES[7175](VELOCITY_Y,0) = 0.000000; -NODES[7175](VELOCITY_Z,0) = 0.000000; -NODES[7176](VELOCITY_X,0) = 0.000000; -NODES[7176](VELOCITY_Y,0) = 0.000000; -NODES[7176](VELOCITY_Z,0) = 0.000000; -NODES[7177](VELOCITY_X,0) = 0.000000; -NODES[7177](VELOCITY_Y,0) = 0.000000; -NODES[7177](VELOCITY_Z,0) = 0.000000; -NODES[7179](VELOCITY_X,0) = 0.000000; -NODES[7179](VELOCITY_Y,0) = 0.000000; -NODES[7179](VELOCITY_Z,0) = 0.000000; -NODES[7183](VELOCITY_X,0) = 0.000000; -NODES[7183](VELOCITY_Y,0) = 0.000000; -NODES[7183](VELOCITY_Z,0) = 0.000000; -NODES[7186](VELOCITY_X,0) = 0.000000; -NODES[7186](VELOCITY_Y,0) = 0.000000; -NODES[7186](VELOCITY_Z,0) = 0.000000; -NODES[7187](VELOCITY_X,0) = 0.000000; -NODES[7187](VELOCITY_Y,0) = 0.000000; -NODES[7187](VELOCITY_Z,0) = 0.000000; -NODES[7203](VELOCITY_X,0) = 0.000000; -NODES[7203](VELOCITY_Y,0) = 0.000000; -NODES[7203](VELOCITY_Z,0) = 0.000000; -NODES[7204](VELOCITY_X,0) = 0.000000; -NODES[7204](VELOCITY_Y,0) = 0.000000; -NODES[7204](VELOCITY_Z,0) = 0.000000; -NODES[7205](VELOCITY_X,0) = 0.000000; -NODES[7205](VELOCITY_Y,0) = 0.000000; -NODES[7205](VELOCITY_Z,0) = 0.000000; -NODES[7206](VELOCITY_X,0) = 0.000000; -NODES[7206](VELOCITY_Y,0) = 0.000000; -NODES[7206](VELOCITY_Z,0) = 0.000000; -NODES[7207](VELOCITY_X,0) = 0.000000; -NODES[7207](VELOCITY_Y,0) = 0.000000; -NODES[7207](VELOCITY_Z,0) = 0.000000; -NODES[7229](VELOCITY_X,0) = 0.000000; -NODES[7229](VELOCITY_Y,0) = 0.000000; -NODES[7229](VELOCITY_Z,0) = 0.000000; -NODES[7232](VELOCITY_X,0) = 0.000000; -NODES[7232](VELOCITY_Y,0) = 0.000000; -NODES[7232](VELOCITY_Z,0) = 0.000000; -NODES[7239](VELOCITY_X,0) = 0.000000; -NODES[7239](VELOCITY_Y,0) = 0.000000; -NODES[7239](VELOCITY_Z,0) = 0.000000; -NODES[7245](VELOCITY_X,0) = 0.000000; -NODES[7245](VELOCITY_Y,0) = 0.000000; -NODES[7245](VELOCITY_Z,0) = 0.000000; -NODES[7246](VELOCITY_X,0) = 0.000000; -NODES[7246](VELOCITY_Y,0) = 0.000000; -NODES[7246](VELOCITY_Z,0) = 0.000000; -NODES[7247](VELOCITY_X,0) = 0.000000; -NODES[7247](VELOCITY_Y,0) = 0.000000; -NODES[7247](VELOCITY_Z,0) = 0.000000; -NODES[7248](VELOCITY_X,0) = 0.000000; -NODES[7248](VELOCITY_Y,0) = 0.000000; -NODES[7248](VELOCITY_Z,0) = 0.000000; -NODES[7251](VELOCITY_X,0) = 0.000000; -NODES[7251](VELOCITY_Y,0) = 0.000000; -NODES[7251](VELOCITY_Z,0) = 0.000000; -NODES[7255](VELOCITY_X,0) = 0.000000; -NODES[7255](VELOCITY_Y,0) = 0.000000; -NODES[7255](VELOCITY_Z,0) = 0.000000; -NODES[7256](VELOCITY_X,0) = 0.000000; -NODES[7256](VELOCITY_Y,0) = 0.000000; -NODES[7256](VELOCITY_Z,0) = 0.000000; -NODES[7261](VELOCITY_X,0) = 0.000000; -NODES[7261](VELOCITY_Y,0) = 0.000000; -NODES[7261](VELOCITY_Z,0) = 0.000000; -NODES[7276](VELOCITY_X,0) = 0.000000; -NODES[7276](VELOCITY_Y,0) = 0.000000; -NODES[7276](VELOCITY_Z,0) = 0.000000; -NODES[7281](VELOCITY_X,0) = 0.000000; -NODES[7281](VELOCITY_Y,0) = 0.000000; -NODES[7281](VELOCITY_Z,0) = 0.000000; -NODES[7282](VELOCITY_X,0) = 0.000000; -NODES[7282](VELOCITY_Y,0) = 0.000000; -NODES[7282](VELOCITY_Z,0) = 0.000000; -NODES[7301](VELOCITY_X,0) = 0.000000; -NODES[7301](VELOCITY_Y,0) = 0.000000; -NODES[7301](VELOCITY_Z,0) = 0.000000; -NODES[7321](VELOCITY_X,0) = 0.000000; -NODES[7321](VELOCITY_Y,0) = 0.000000; -NODES[7321](VELOCITY_Z,0) = 0.000000; -NODES[7322](VELOCITY_X,0) = 0.000000; -NODES[7322](VELOCITY_Y,0) = 0.000000; -NODES[7322](VELOCITY_Z,0) = 0.000000; -NODES[7323](VELOCITY_X,0) = 0.000000; -NODES[7323](VELOCITY_Y,0) = 0.000000; -NODES[7323](VELOCITY_Z,0) = 0.000000; -NODES[7324](VELOCITY_X,0) = 0.000000; -NODES[7324](VELOCITY_Y,0) = 0.000000; -NODES[7324](VELOCITY_Z,0) = 0.000000; -NODES[7325](VELOCITY_X,0) = 0.000000; -NODES[7325](VELOCITY_Y,0) = 0.000000; -NODES[7325](VELOCITY_Z,0) = 0.000000; -NODES[7327](VELOCITY_X,0) = 0.000000; -NODES[7327](VELOCITY_Y,0) = 0.000000; -NODES[7327](VELOCITY_Z,0) = 0.000000; -NODES[7331](VELOCITY_X,0) = 0.000000; -NODES[7331](VELOCITY_Y,0) = 0.000000; -NODES[7331](VELOCITY_Z,0) = 0.000000; -NODES[7334](VELOCITY_X,0) = 0.000000; -NODES[7334](VELOCITY_Y,0) = 0.000000; -NODES[7334](VELOCITY_Z,0) = 0.000000; -NODES[7335](VELOCITY_X,0) = 0.000000; -NODES[7335](VELOCITY_Y,0) = 0.000000; -NODES[7335](VELOCITY_Z,0) = 0.000000; -NODES[7338](VELOCITY_X,0) = 0.000000; -NODES[7338](VELOCITY_Y,0) = 0.000000; -NODES[7338](VELOCITY_Z,0) = 0.000000; -NODES[7345](VELOCITY_X,0) = 0.000000; -NODES[7345](VELOCITY_Y,0) = 0.000000; -NODES[7345](VELOCITY_Z,0) = 0.000000; -NODES[7349](VELOCITY_X,0) = 0.000000; -NODES[7349](VELOCITY_Y,0) = 0.000000; -NODES[7349](VELOCITY_Z,0) = 0.000000; -NODES[7350](VELOCITY_X,0) = 0.000000; -NODES[7350](VELOCITY_Y,0) = 0.000000; -NODES[7350](VELOCITY_Z,0) = 0.000000; -NODES[7361](VELOCITY_X,0) = 0.000000; -NODES[7361](VELOCITY_Y,0) = 0.000000; -NODES[7361](VELOCITY_Z,0) = 0.000000; -NODES[7366](VELOCITY_X,0) = 0.000000; -NODES[7366](VELOCITY_Y,0) = 0.000000; -NODES[7366](VELOCITY_Z,0) = 0.000000; -NODES[7369](VELOCITY_X,0) = 0.000000; -NODES[7369](VELOCITY_Y,0) = 0.000000; -NODES[7369](VELOCITY_Z,0) = 0.000000; -NODES[7370](VELOCITY_X,0) = 0.000000; -NODES[7370](VELOCITY_Y,0) = 0.000000; -NODES[7370](VELOCITY_Z,0) = 0.000000; -NODES[7380](VELOCITY_X,0) = 0.000000; -NODES[7380](VELOCITY_Y,0) = 0.000000; -NODES[7380](VELOCITY_Z,0) = 0.000000; -NODES[7383](VELOCITY_X,0) = 0.000000; -NODES[7383](VELOCITY_Y,0) = 0.000000; -NODES[7383](VELOCITY_Z,0) = 0.000000; -NODES[7384](VELOCITY_X,0) = 0.000000; -NODES[7384](VELOCITY_Y,0) = 0.000000; -NODES[7384](VELOCITY_Z,0) = 0.000000; -NODES[7386](VELOCITY_X,0) = 0.000000; -NODES[7386](VELOCITY_Y,0) = 0.000000; -NODES[7386](VELOCITY_Z,0) = 0.000000; -NODES[7388](VELOCITY_X,0) = 0.000000; -NODES[7388](VELOCITY_Y,0) = 0.000000; -NODES[7388](VELOCITY_Z,0) = 0.000000; -NODES[7389](VELOCITY_X,0) = 0.000000; -NODES[7389](VELOCITY_Y,0) = 0.000000; -NODES[7389](VELOCITY_Z,0) = 0.000000; -NODES[7394](VELOCITY_X,0) = 0.000000; -NODES[7394](VELOCITY_Y,0) = 0.000000; -NODES[7394](VELOCITY_Z,0) = 0.000000; -NODES[7397](VELOCITY_X,0) = 0.000000; -NODES[7397](VELOCITY_Y,0) = 0.000000; -NODES[7397](VELOCITY_Z,0) = 0.000000; -NODES[7398](VELOCITY_X,0) = 0.000000; -NODES[7398](VELOCITY_Y,0) = 0.000000; -NODES[7398](VELOCITY_Z,0) = 0.000000; -NODES[7399](VELOCITY_X,0) = 0.000000; -NODES[7399](VELOCITY_Y,0) = 0.000000; -NODES[7399](VELOCITY_Z,0) = 0.000000; -NODES[7400](VELOCITY_X,0) = 0.000000; -NODES[7400](VELOCITY_Y,0) = 0.000000; -NODES[7400](VELOCITY_Z,0) = 0.000000; -NODES[7404](VELOCITY_X,0) = 0.000000; -NODES[7404](VELOCITY_Y,0) = 0.000000; -NODES[7404](VELOCITY_Z,0) = 0.000000; -NODES[7405](VELOCITY_X,0) = 0.000000; -NODES[7405](VELOCITY_Y,0) = 0.000000; -NODES[7405](VELOCITY_Z,0) = 0.000000; -NODES[7412](VELOCITY_X,0) = 0.000000; -NODES[7412](VELOCITY_Y,0) = 0.000000; -NODES[7412](VELOCITY_Z,0) = 0.000000; -NODES[7414](VELOCITY_X,0) = 0.000000; -NODES[7414](VELOCITY_Y,0) = 0.000000; -NODES[7414](VELOCITY_Z,0) = 0.000000; -NODES[7415](VELOCITY_X,0) = 0.000000; -NODES[7415](VELOCITY_Y,0) = 0.000000; -NODES[7415](VELOCITY_Z,0) = 0.000000; -NODES[7423](VELOCITY_X,0) = 0.000000; -NODES[7423](VELOCITY_Y,0) = 0.000000; -NODES[7423](VELOCITY_Z,0) = 0.000000; -NODES[7430](VELOCITY_X,0) = 0.000000; -NODES[7430](VELOCITY_Y,0) = 0.000000; -NODES[7430](VELOCITY_Z,0) = 0.000000; -NODES[7434](VELOCITY_X,0) = 0.000000; -NODES[7434](VELOCITY_Y,0) = 0.000000; -NODES[7434](VELOCITY_Z,0) = 0.000000; -NODES[7435](VELOCITY_X,0) = 0.000000; -NODES[7435](VELOCITY_Y,0) = 0.000000; -NODES[7435](VELOCITY_Z,0) = 0.000000; -NODES[7436](VELOCITY_X,0) = 0.000000; -NODES[7436](VELOCITY_Y,0) = 0.000000; -NODES[7436](VELOCITY_Z,0) = 0.000000; -NODES[7437](VELOCITY_X,0) = 0.000000; -NODES[7437](VELOCITY_Y,0) = 0.000000; -NODES[7437](VELOCITY_Z,0) = 0.000000; -NODES[7438](VELOCITY_X,0) = 0.000000; -NODES[7438](VELOCITY_Y,0) = 0.000000; -NODES[7438](VELOCITY_Z,0) = 0.000000; -NODES[7439](VELOCITY_X,0) = 0.000000; -NODES[7439](VELOCITY_Y,0) = 0.000000; -NODES[7439](VELOCITY_Z,0) = 0.000000; -NODES[7440](VELOCITY_X,0) = 0.000000; -NODES[7440](VELOCITY_Y,0) = 0.000000; -NODES[7440](VELOCITY_Z,0) = 0.000000; -NODES[7441](VELOCITY_X,0) = 0.000000; -NODES[7441](VELOCITY_Y,0) = 0.000000; -NODES[7441](VELOCITY_Z,0) = 0.000000; -NODES[7444](VELOCITY_X,0) = 0.000000; -NODES[7444](VELOCITY_Y,0) = 0.000000; -NODES[7444](VELOCITY_Z,0) = 0.000000; -NODES[7449](VELOCITY_X,0) = 0.000000; -NODES[7449](VELOCITY_Y,0) = 0.000000; -NODES[7449](VELOCITY_Z,0) = 0.000000; -NODES[7453](VELOCITY_X,0) = 0.000000; -NODES[7453](VELOCITY_Y,0) = 0.000000; -NODES[7453](VELOCITY_Z,0) = 0.000000; -NODES[7455](VELOCITY_X,0) = 0.000000; -NODES[7455](VELOCITY_Y,0) = 0.000000; -NODES[7455](VELOCITY_Z,0) = 0.000000; -NODES[7462](VELOCITY_X,0) = 0.000000; -NODES[7462](VELOCITY_Y,0) = 0.000000; -NODES[7462](VELOCITY_Z,0) = 0.000000; -NODES[7463](VELOCITY_X,0) = 0.000000; -NODES[7463](VELOCITY_Y,0) = 0.000000; -NODES[7463](VELOCITY_Z,0) = 0.000000; -NODES[7464](VELOCITY_X,0) = 0.000000; -NODES[7464](VELOCITY_Y,0) = 0.000000; -NODES[7464](VELOCITY_Z,0) = 0.000000; -NODES[7469](VELOCITY_X,0) = 0.000000; -NODES[7469](VELOCITY_Y,0) = 0.000000; -NODES[7469](VELOCITY_Z,0) = 0.000000; -NODES[7473](VELOCITY_X,0) = 0.000000; -NODES[7473](VELOCITY_Y,0) = 0.000000; -NODES[7473](VELOCITY_Z,0) = 0.000000; -NODES[7474](VELOCITY_X,0) = 0.000000; -NODES[7474](VELOCITY_Y,0) = 0.000000; -NODES[7474](VELOCITY_Z,0) = 0.000000; -NODES[7476](VELOCITY_X,0) = 0.000000; -NODES[7476](VELOCITY_Y,0) = 0.000000; -NODES[7476](VELOCITY_Z,0) = 0.000000; -NODES[7479](VELOCITY_X,0) = 0.000000; -NODES[7479](VELOCITY_Y,0) = 0.000000; -NODES[7479](VELOCITY_Z,0) = 0.000000; -NODES[7480](VELOCITY_X,0) = 0.000000; -NODES[7480](VELOCITY_Y,0) = 0.000000; -NODES[7480](VELOCITY_Z,0) = 0.000000; -NODES[7481](VELOCITY_X,0) = 0.000000; -NODES[7481](VELOCITY_Y,0) = 0.000000; -NODES[7481](VELOCITY_Z,0) = 0.000000; -NODES[7503](VELOCITY_X,0) = 0.000000; -NODES[7503](VELOCITY_Y,0) = 0.000000; -NODES[7503](VELOCITY_Z,0) = 0.000000; -NODES[7504](VELOCITY_X,0) = 0.000000; -NODES[7504](VELOCITY_Y,0) = 0.000000; -NODES[7504](VELOCITY_Z,0) = 0.000000; -NODES[7506](VELOCITY_X,0) = 0.000000; -NODES[7506](VELOCITY_Y,0) = 0.000000; -NODES[7506](VELOCITY_Z,0) = 0.000000; -NODES[7518](VELOCITY_X,0) = 0.000000; -NODES[7518](VELOCITY_Y,0) = 0.000000; -NODES[7518](VELOCITY_Z,0) = 0.000000; -NODES[7521](VELOCITY_X,0) = 0.000000; -NODES[7521](VELOCITY_Y,0) = 0.000000; -NODES[7521](VELOCITY_Z,0) = 0.000000; -NODES[7522](VELOCITY_X,0) = 0.000000; -NODES[7522](VELOCITY_Y,0) = 0.000000; -NODES[7522](VELOCITY_Z,0) = 0.000000; -NODES[7527](VELOCITY_X,0) = 0.000000; -NODES[7527](VELOCITY_Y,0) = 0.000000; -NODES[7527](VELOCITY_Z,0) = 0.000000; -NODES[7528](VELOCITY_X,0) = 0.000000; -NODES[7528](VELOCITY_Y,0) = 0.000000; -NODES[7528](VELOCITY_Z,0) = 0.000000; -NODES[7530](VELOCITY_X,0) = 0.000000; -NODES[7530](VELOCITY_Y,0) = 0.000000; -NODES[7530](VELOCITY_Z,0) = 0.000000; -NODES[7531](VELOCITY_X,0) = 0.000000; -NODES[7531](VELOCITY_Y,0) = 0.000000; -NODES[7531](VELOCITY_Z,0) = 0.000000; -NODES[7533](VELOCITY_X,0) = 0.000000; -NODES[7533](VELOCITY_Y,0) = 0.000000; -NODES[7533](VELOCITY_Z,0) = 0.000000; -NODES[7534](VELOCITY_X,0) = 0.000000; -NODES[7534](VELOCITY_Y,0) = 0.000000; -NODES[7534](VELOCITY_Z,0) = 0.000000; -NODES[7546](VELOCITY_X,0) = 0.000000; -NODES[7546](VELOCITY_Y,0) = 0.000000; -NODES[7546](VELOCITY_Z,0) = 0.000000; -NODES[7547](VELOCITY_X,0) = 0.000000; -NODES[7547](VELOCITY_Y,0) = 0.000000; -NODES[7547](VELOCITY_Z,0) = 0.000000; -NODES[7548](VELOCITY_X,0) = 0.000000; -NODES[7548](VELOCITY_Y,0) = 0.000000; -NODES[7548](VELOCITY_Z,0) = 0.000000; -NODES[7549](VELOCITY_X,0) = 0.000000; -NODES[7549](VELOCITY_Y,0) = 0.000000; -NODES[7549](VELOCITY_Z,0) = 0.000000; -NODES[7552](VELOCITY_X,0) = 0.000000; -NODES[7552](VELOCITY_Y,0) = 0.000000; -NODES[7552](VELOCITY_Z,0) = 0.000000; -NODES[7561](VELOCITY_X,0) = 0.000000; -NODES[7561](VELOCITY_Y,0) = 0.000000; -NODES[7561](VELOCITY_Z,0) = 0.000000; -NODES[7562](VELOCITY_X,0) = 0.000000; -NODES[7562](VELOCITY_Y,0) = 0.000000; -NODES[7562](VELOCITY_Z,0) = 0.000000; -NODES[7563](VELOCITY_X,0) = 0.000000; -NODES[7563](VELOCITY_Y,0) = 0.000000; -NODES[7563](VELOCITY_Z,0) = 0.000000; -NODES[7564](VELOCITY_X,0) = 0.000000; -NODES[7564](VELOCITY_Y,0) = 0.000000; -NODES[7564](VELOCITY_Z,0) = 0.000000; -NODES[7565](VELOCITY_X,0) = 0.000000; -NODES[7565](VELOCITY_Y,0) = 0.000000; -NODES[7565](VELOCITY_Z,0) = 0.000000; -NODES[7570](VELOCITY_X,0) = 0.000000; -NODES[7570](VELOCITY_Y,0) = 0.000000; -NODES[7570](VELOCITY_Z,0) = 0.000000; -NODES[7575](VELOCITY_X,0) = 0.000000; -NODES[7575](VELOCITY_Y,0) = 0.000000; -NODES[7575](VELOCITY_Z,0) = 0.000000; -NODES[7576](VELOCITY_X,0) = 0.000000; -NODES[7576](VELOCITY_Y,0) = 0.000000; -NODES[7576](VELOCITY_Z,0) = 0.000000; -NODES[7577](VELOCITY_X,0) = 0.000000; -NODES[7577](VELOCITY_Y,0) = 0.000000; -NODES[7577](VELOCITY_Z,0) = 0.000000; -NODES[7592](VELOCITY_X,0) = 0.000000; -NODES[7592](VELOCITY_Y,0) = 0.000000; -NODES[7592](VELOCITY_Z,0) = 0.000000; -NODES[7596](VELOCITY_X,0) = 0.000000; -NODES[7596](VELOCITY_Y,0) = 0.000000; -NODES[7596](VELOCITY_Z,0) = 0.000000; -NODES[7620](VELOCITY_X,0) = 0.000000; -NODES[7620](VELOCITY_Y,0) = 0.000000; -NODES[7620](VELOCITY_Z,0) = 0.000000; -NODES[7625](VELOCITY_X,0) = 0.000000; -NODES[7625](VELOCITY_Y,0) = 0.000000; -NODES[7625](VELOCITY_Z,0) = 0.000000; -NODES[7630](VELOCITY_X,0) = 0.000000; -NODES[7630](VELOCITY_Y,0) = 0.000000; -NODES[7630](VELOCITY_Z,0) = 0.000000; -NODES[7631](VELOCITY_X,0) = 0.000000; -NODES[7631](VELOCITY_Y,0) = 0.000000; -NODES[7631](VELOCITY_Z,0) = 0.000000; -NODES[7636](VELOCITY_X,0) = 0.000000; -NODES[7636](VELOCITY_Y,0) = 0.000000; -NODES[7636](VELOCITY_Z,0) = 0.000000; -NODES[7637](VELOCITY_X,0) = 0.000000; -NODES[7637](VELOCITY_Y,0) = 0.000000; -NODES[7637](VELOCITY_Z,0) = 0.000000; -NODES[7638](VELOCITY_X,0) = 0.000000; -NODES[7638](VELOCITY_Y,0) = 0.000000; -NODES[7638](VELOCITY_Z,0) = 0.000000; -NODES[7642](VELOCITY_X,0) = 0.000000; -NODES[7642](VELOCITY_Y,0) = 0.000000; -NODES[7642](VELOCITY_Z,0) = 0.000000; -NODES[7643](VELOCITY_X,0) = 0.000000; -NODES[7643](VELOCITY_Y,0) = 0.000000; -NODES[7643](VELOCITY_Z,0) = 0.000000; -NODES[7645](VELOCITY_X,0) = 0.000000; -NODES[7645](VELOCITY_Y,0) = 0.000000; -NODES[7645](VELOCITY_Z,0) = 0.000000; -NODES[7646](VELOCITY_X,0) = 0.000000; -NODES[7646](VELOCITY_Y,0) = 0.000000; -NODES[7646](VELOCITY_Z,0) = 0.000000; -NODES[7654](VELOCITY_X,0) = 0.000000; -NODES[7654](VELOCITY_Y,0) = 0.000000; -NODES[7654](VELOCITY_Z,0) = 0.000000; -NODES[7656](VELOCITY_X,0) = 0.000000; -NODES[7656](VELOCITY_Y,0) = 0.000000; -NODES[7656](VELOCITY_Z,0) = 0.000000; -NODES[7660](VELOCITY_X,0) = 0.000000; -NODES[7660](VELOCITY_Y,0) = 0.000000; -NODES[7660](VELOCITY_Z,0) = 0.000000; -NODES[7670](VELOCITY_X,0) = 0.000000; -NODES[7670](VELOCITY_Y,0) = 0.000000; -NODES[7670](VELOCITY_Z,0) = 0.000000; -NODES[7683](VELOCITY_X,0) = 0.000000; -NODES[7683](VELOCITY_Y,0) = 0.000000; -NODES[7683](VELOCITY_Z,0) = 0.000000; -NODES[7684](VELOCITY_X,0) = 0.000000; -NODES[7684](VELOCITY_Y,0) = 0.000000; -NODES[7684](VELOCITY_Z,0) = 0.000000; -NODES[7685](VELOCITY_X,0) = 0.000000; -NODES[7685](VELOCITY_Y,0) = 0.000000; -NODES[7685](VELOCITY_Z,0) = 0.000000; -NODES[7686](VELOCITY_X,0) = 0.000000; -NODES[7686](VELOCITY_Y,0) = 0.000000; -NODES[7686](VELOCITY_Z,0) = 0.000000; -NODES[7687](VELOCITY_X,0) = 0.000000; -NODES[7687](VELOCITY_Y,0) = 0.000000; -NODES[7687](VELOCITY_Z,0) = 0.000000; -NODES[7688](VELOCITY_X,0) = 0.000000; -NODES[7688](VELOCITY_Y,0) = 0.000000; -NODES[7688](VELOCITY_Z,0) = 0.000000; -NODES[7689](VELOCITY_X,0) = 0.000000; -NODES[7689](VELOCITY_Y,0) = 0.000000; -NODES[7689](VELOCITY_Z,0) = 0.000000; -NODES[7694](VELOCITY_X,0) = 0.000000; -NODES[7694](VELOCITY_Y,0) = 0.000000; -NODES[7694](VELOCITY_Z,0) = 0.000000; -NODES[7695](VELOCITY_X,0) = 0.000000; -NODES[7695](VELOCITY_Y,0) = 0.000000; -NODES[7695](VELOCITY_Z,0) = 0.000000; -NODES[7697](VELOCITY_X,0) = 0.000000; -NODES[7697](VELOCITY_Y,0) = 0.000000; -NODES[7697](VELOCITY_Z,0) = 0.000000; -NODES[7700](VELOCITY_X,0) = 0.000000; -NODES[7700](VELOCITY_Y,0) = 0.000000; -NODES[7700](VELOCITY_Z,0) = 0.000000; -NODES[7702](VELOCITY_X,0) = 0.000000; -NODES[7702](VELOCITY_Y,0) = 0.000000; -NODES[7702](VELOCITY_Z,0) = 0.000000; -NODES[7708](VELOCITY_X,0) = 0.000000; -NODES[7708](VELOCITY_Y,0) = 0.000000; -NODES[7708](VELOCITY_Z,0) = 0.000000; -NODES[7709](VELOCITY_X,0) = 0.000000; -NODES[7709](VELOCITY_Y,0) = 0.000000; -NODES[7709](VELOCITY_Z,0) = 0.000000; -NODES[7710](VELOCITY_X,0) = 0.000000; -NODES[7710](VELOCITY_Y,0) = 0.000000; -NODES[7710](VELOCITY_Z,0) = 0.000000; -NODES[7718](VELOCITY_X,0) = 0.000000; -NODES[7718](VELOCITY_Y,0) = 0.000000; -NODES[7718](VELOCITY_Z,0) = 0.000000; -NODES[7729](VELOCITY_X,0) = 0.000000; -NODES[7729](VELOCITY_Y,0) = 0.000000; -NODES[7729](VELOCITY_Z,0) = 0.000000; -NODES[7735](VELOCITY_X,0) = 0.000000; -NODES[7735](VELOCITY_Y,0) = 0.000000; -NODES[7735](VELOCITY_Z,0) = 0.000000; -NODES[7736](VELOCITY_X,0) = 0.000000; -NODES[7736](VELOCITY_Y,0) = 0.000000; -NODES[7736](VELOCITY_Z,0) = 0.000000; -NODES[7738](VELOCITY_X,0) = 0.000000; -NODES[7738](VELOCITY_Y,0) = 0.000000; -NODES[7738](VELOCITY_Z,0) = 0.000000; -NODES[7739](VELOCITY_X,0) = 0.000000; -NODES[7739](VELOCITY_Y,0) = 0.000000; -NODES[7739](VELOCITY_Z,0) = 0.000000; -NODES[7748](VELOCITY_X,0) = 0.000000; -NODES[7748](VELOCITY_Y,0) = 0.000000; -NODES[7748](VELOCITY_Z,0) = 0.000000; -NODES[7751](VELOCITY_X,0) = 0.000000; -NODES[7751](VELOCITY_Y,0) = 0.000000; -NODES[7751](VELOCITY_Z,0) = 0.000000; -NODES[7752](VELOCITY_X,0) = 0.000000; -NODES[7752](VELOCITY_Y,0) = 0.000000; -NODES[7752](VELOCITY_Z,0) = 0.000000; -NODES[7758](VELOCITY_X,0) = 0.000000; -NODES[7758](VELOCITY_Y,0) = 0.000000; -NODES[7758](VELOCITY_Z,0) = 0.000000; -NODES[7759](VELOCITY_X,0) = 0.000000; -NODES[7759](VELOCITY_Y,0) = 0.000000; -NODES[7759](VELOCITY_Z,0) = 0.000000; -NODES[7765](VELOCITY_X,0) = 0.000000; -NODES[7765](VELOCITY_Y,0) = 0.000000; -NODES[7765](VELOCITY_Z,0) = 0.000000; -NODES[7766](VELOCITY_X,0) = 0.000000; -NODES[7766](VELOCITY_Y,0) = 0.000000; -NODES[7766](VELOCITY_Z,0) = 0.000000; -NODES[7770](VELOCITY_X,0) = 0.000000; -NODES[7770](VELOCITY_Y,0) = 0.000000; -NODES[7770](VELOCITY_Z,0) = 0.000000; -NODES[7774](VELOCITY_X,0) = 0.000000; -NODES[7774](VELOCITY_Y,0) = 0.000000; -NODES[7774](VELOCITY_Z,0) = 0.000000; -NODES[7782](VELOCITY_X,0) = 0.000000; -NODES[7782](VELOCITY_Y,0) = 0.000000; -NODES[7782](VELOCITY_Z,0) = 0.000000; -NODES[7792](VELOCITY_X,0) = 0.000000; -NODES[7792](VELOCITY_Y,0) = 0.000000; -NODES[7792](VELOCITY_Z,0) = 0.000000; -NODES[7793](VELOCITY_X,0) = 0.000000; -NODES[7793](VELOCITY_Y,0) = 0.000000; -NODES[7793](VELOCITY_Z,0) = 0.000000; -NODES[7796](VELOCITY_X,0) = 0.000000; -NODES[7796](VELOCITY_Y,0) = 0.000000; -NODES[7796](VELOCITY_Z,0) = 0.000000; -NODES[7797](VELOCITY_X,0) = 0.000000; -NODES[7797](VELOCITY_Y,0) = 0.000000; -NODES[7797](VELOCITY_Z,0) = 0.000000; -NODES[7798](VELOCITY_X,0) = 0.000000; -NODES[7798](VELOCITY_Y,0) = 0.000000; -NODES[7798](VELOCITY_Z,0) = 0.000000; -NODES[7799](VELOCITY_X,0) = 0.000000; -NODES[7799](VELOCITY_Y,0) = 0.000000; -NODES[7799](VELOCITY_Z,0) = 0.000000; -NODES[7800](VELOCITY_X,0) = 0.000000; -NODES[7800](VELOCITY_Y,0) = 0.000000; -NODES[7800](VELOCITY_Z,0) = 0.000000; -NODES[7801](VELOCITY_X,0) = 0.000000; -NODES[7801](VELOCITY_Y,0) = 0.000000; -NODES[7801](VELOCITY_Z,0) = 0.000000; -NODES[7802](VELOCITY_X,0) = 0.000000; -NODES[7802](VELOCITY_Y,0) = 0.000000; -NODES[7802](VELOCITY_Z,0) = 0.000000; -NODES[7816](VELOCITY_X,0) = 0.000000; -NODES[7816](VELOCITY_Y,0) = 0.000000; -NODES[7816](VELOCITY_Z,0) = 0.000000; -NODES[7824](VELOCITY_X,0) = 0.000000; -NODES[7824](VELOCITY_Y,0) = 0.000000; -NODES[7824](VELOCITY_Z,0) = 0.000000; -NODES[7830](VELOCITY_X,0) = 0.000000; -NODES[7830](VELOCITY_Y,0) = 0.000000; -NODES[7830](VELOCITY_Z,0) = 0.000000; -NODES[7834](VELOCITY_X,0) = 0.000000; -NODES[7834](VELOCITY_Y,0) = 0.000000; -NODES[7834](VELOCITY_Z,0) = 0.000000; -NODES[7835](VELOCITY_X,0) = 0.000000; -NODES[7835](VELOCITY_Y,0) = 0.000000; -NODES[7835](VELOCITY_Z,0) = 0.000000; -NODES[7846](VELOCITY_X,0) = 0.000000; -NODES[7846](VELOCITY_Y,0) = 0.000000; -NODES[7846](VELOCITY_Z,0) = 0.000000; -NODES[7857](VELOCITY_X,0) = 0.000000; -NODES[7857](VELOCITY_Y,0) = 0.000000; -NODES[7857](VELOCITY_Z,0) = 0.000000; -NODES[7859](VELOCITY_X,0) = 0.000000; -NODES[7859](VELOCITY_Y,0) = 0.000000; -NODES[7859](VELOCITY_Z,0) = 0.000000; -NODES[7865](VELOCITY_X,0) = 0.000000; -NODES[7865](VELOCITY_Y,0) = 0.000000; -NODES[7865](VELOCITY_Z,0) = 0.000000; -NODES[7876](VELOCITY_X,0) = 0.000000; -NODES[7876](VELOCITY_Y,0) = 0.000000; -NODES[7876](VELOCITY_Z,0) = 0.000000; -NODES[7877](VELOCITY_X,0) = 0.000000; -NODES[7877](VELOCITY_Y,0) = 0.000000; -NODES[7877](VELOCITY_Z,0) = 0.000000; -NODES[7878](VELOCITY_X,0) = 0.000000; -NODES[7878](VELOCITY_Y,0) = 0.000000; -NODES[7878](VELOCITY_Z,0) = 0.000000; -NODES[7879](VELOCITY_X,0) = 0.000000; -NODES[7879](VELOCITY_Y,0) = 0.000000; -NODES[7879](VELOCITY_Z,0) = 0.000000; -NODES[7884](VELOCITY_X,0) = 0.000000; -NODES[7884](VELOCITY_Y,0) = 0.000000; -NODES[7884](VELOCITY_Z,0) = 0.000000; -NODES[7885](VELOCITY_X,0) = 0.000000; -NODES[7885](VELOCITY_Y,0) = 0.000000; -NODES[7885](VELOCITY_Z,0) = 0.000000; -NODES[7891](VELOCITY_X,0) = 0.000000; -NODES[7891](VELOCITY_Y,0) = 0.000000; -NODES[7891](VELOCITY_Z,0) = 0.000000; -NODES[7896](VELOCITY_X,0) = 0.000000; -NODES[7896](VELOCITY_Y,0) = 0.000000; -NODES[7896](VELOCITY_Z,0) = 0.000000; -NODES[7901](VELOCITY_X,0) = 0.000000; -NODES[7901](VELOCITY_Y,0) = 0.000000; -NODES[7901](VELOCITY_Z,0) = 0.000000; -NODES[7902](VELOCITY_X,0) = 0.000000; -NODES[7902](VELOCITY_Y,0) = 0.000000; -NODES[7902](VELOCITY_Z,0) = 0.000000; -NODES[7906](VELOCITY_X,0) = 0.000000; -NODES[7906](VELOCITY_Y,0) = 0.000000; -NODES[7906](VELOCITY_Z,0) = 0.000000; -NODES[7913](VELOCITY_X,0) = 0.000000; -NODES[7913](VELOCITY_Y,0) = 0.000000; -NODES[7913](VELOCITY_Z,0) = 0.000000; -NODES[7915](VELOCITY_X,0) = 0.000000; -NODES[7915](VELOCITY_Y,0) = 0.000000; -NODES[7915](VELOCITY_Z,0) = 0.000000; -NODES[7933](VELOCITY_X,0) = 0.000000; -NODES[7933](VELOCITY_Y,0) = 0.000000; -NODES[7933](VELOCITY_Z,0) = 0.000000; -NODES[7945](VELOCITY_X,0) = 0.000000; -NODES[7945](VELOCITY_Y,0) = 0.000000; -NODES[7945](VELOCITY_Z,0) = 0.000000; -NODES[7946](VELOCITY_X,0) = 0.000000; -NODES[7946](VELOCITY_Y,0) = 0.000000; -NODES[7946](VELOCITY_Z,0) = 0.000000; -NODES[7947](VELOCITY_X,0) = 0.000000; -NODES[7947](VELOCITY_Y,0) = 0.000000; -NODES[7947](VELOCITY_Z,0) = 0.000000; -NODES[7948](VELOCITY_X,0) = 0.000000; -NODES[7948](VELOCITY_Y,0) = 0.000000; -NODES[7948](VELOCITY_Z,0) = 0.000000; -NODES[7949](VELOCITY_X,0) = 0.000000; -NODES[7949](VELOCITY_Y,0) = 0.000000; -NODES[7949](VELOCITY_Z,0) = 0.000000; -NODES[7956](VELOCITY_X,0) = 0.000000; -NODES[7956](VELOCITY_Y,0) = 0.000000; -NODES[7956](VELOCITY_Z,0) = 0.000000; -NODES[7963](VELOCITY_X,0) = 0.000000; -NODES[7963](VELOCITY_Y,0) = 0.000000; -NODES[7963](VELOCITY_Z,0) = 0.000000; -NODES[7964](VELOCITY_X,0) = 0.000000; -NODES[7964](VELOCITY_Y,0) = 0.000000; -NODES[7964](VELOCITY_Z,0) = 0.000000; -NODES[7986](VELOCITY_X,0) = 0.000000; -NODES[7986](VELOCITY_Y,0) = 0.000000; -NODES[7986](VELOCITY_Z,0) = 0.000000; -NODES[7987](VELOCITY_X,0) = 0.000000; -NODES[7987](VELOCITY_Y,0) = 0.000000; -NODES[7987](VELOCITY_Z,0) = 0.000000; -NODES[7988](VELOCITY_X,0) = 0.000000; -NODES[7988](VELOCITY_Y,0) = 0.000000; -NODES[7988](VELOCITY_Z,0) = 0.000000; -NODES[7989](VELOCITY_X,0) = 0.000000; -NODES[7989](VELOCITY_Y,0) = 0.000000; -NODES[7989](VELOCITY_Z,0) = 0.000000; -NODES[7999](VELOCITY_X,0) = 0.000000; -NODES[7999](VELOCITY_Y,0) = 0.000000; -NODES[7999](VELOCITY_Z,0) = 0.000000; -NODES[8003](VELOCITY_X,0) = 0.000000; -NODES[8003](VELOCITY_Y,0) = 0.000000; -NODES[8003](VELOCITY_Z,0) = 0.000000; -NODES[8004](VELOCITY_X,0) = 0.000000; -NODES[8004](VELOCITY_Y,0) = 0.000000; -NODES[8004](VELOCITY_Z,0) = 0.000000; -NODES[8005](VELOCITY_X,0) = 0.000000; -NODES[8005](VELOCITY_Y,0) = 0.000000; -NODES[8005](VELOCITY_Z,0) = 0.000000; -NODES[8008](VELOCITY_X,0) = 0.000000; -NODES[8008](VELOCITY_Y,0) = 0.000000; -NODES[8008](VELOCITY_Z,0) = 0.000000; -NODES[8011](VELOCITY_X,0) = 0.000000; -NODES[8011](VELOCITY_Y,0) = 0.000000; -NODES[8011](VELOCITY_Z,0) = 0.000000; -NODES[8016](VELOCITY_X,0) = 0.000000; -NODES[8016](VELOCITY_Y,0) = 0.000000; -NODES[8016](VELOCITY_Z,0) = 0.000000; -NODES[8025](VELOCITY_X,0) = 0.000000; -NODES[8025](VELOCITY_Y,0) = 0.000000; -NODES[8025](VELOCITY_Z,0) = 0.000000; -NODES[8026](VELOCITY_X,0) = 0.000000; -NODES[8026](VELOCITY_Y,0) = 0.000000; -NODES[8026](VELOCITY_Z,0) = 0.000000; -NODES[8031](VELOCITY_X,0) = 0.000000; -NODES[8031](VELOCITY_Y,0) = 0.000000; -NODES[8031](VELOCITY_Z,0) = 0.000000; -NODES[8037](VELOCITY_X,0) = 0.000000; -NODES[8037](VELOCITY_Y,0) = 0.000000; -NODES[8037](VELOCITY_Z,0) = 0.000000; -NODES[8038](VELOCITY_X,0) = 0.000000; -NODES[8038](VELOCITY_Y,0) = 0.000000; -NODES[8038](VELOCITY_Z,0) = 0.000000; -NODES[8039](VELOCITY_X,0) = 0.000000; -NODES[8039](VELOCITY_Y,0) = 0.000000; -NODES[8039](VELOCITY_Z,0) = 0.000000; -NODES[8040](VELOCITY_X,0) = 0.000000; -NODES[8040](VELOCITY_Y,0) = 0.000000; -NODES[8040](VELOCITY_Z,0) = 0.000000; -NODES[8041](VELOCITY_X,0) = 0.000000; -NODES[8041](VELOCITY_Y,0) = 0.000000; -NODES[8041](VELOCITY_Z,0) = 0.000000; -NODES[8047](VELOCITY_X,0) = 0.000000; -NODES[8047](VELOCITY_Y,0) = 0.000000; -NODES[8047](VELOCITY_Z,0) = 0.000000; -NODES[8059](VELOCITY_X,0) = 0.000000; -NODES[8059](VELOCITY_Y,0) = 0.000000; -NODES[8059](VELOCITY_Z,0) = 0.000000; -NODES[8060](VELOCITY_X,0) = 0.000000; -NODES[8060](VELOCITY_Y,0) = 0.000000; -NODES[8060](VELOCITY_Z,0) = 0.000000; -NODES[8061](VELOCITY_X,0) = 0.000000; -NODES[8061](VELOCITY_Y,0) = 0.000000; -NODES[8061](VELOCITY_Z,0) = 0.000000; -NODES[8077](VELOCITY_X,0) = 0.000000; -NODES[8077](VELOCITY_Y,0) = 0.000000; -NODES[8077](VELOCITY_Z,0) = 0.000000; -NODES[8086](VELOCITY_X,0) = 0.000000; -NODES[8086](VELOCITY_Y,0) = 0.000000; -NODES[8086](VELOCITY_Z,0) = 0.000000; -NODES[8087](VELOCITY_X,0) = 0.000000; -NODES[8087](VELOCITY_Y,0) = 0.000000; -NODES[8087](VELOCITY_Z,0) = 0.000000; -NODES[8088](VELOCITY_X,0) = 0.000000; -NODES[8088](VELOCITY_Y,0) = 0.000000; -NODES[8088](VELOCITY_Z,0) = 0.000000; -NODES[8092](VELOCITY_X,0) = 0.000000; -NODES[8092](VELOCITY_Y,0) = 0.000000; -NODES[8092](VELOCITY_Z,0) = 0.000000; -NODES[8099](VELOCITY_X,0) = 0.000000; -NODES[8099](VELOCITY_Y,0) = 0.000000; -NODES[8099](VELOCITY_Z,0) = 0.000000; -NODES[8100](VELOCITY_X,0) = 0.000000; -NODES[8100](VELOCITY_Y,0) = 0.000000; -NODES[8100](VELOCITY_Z,0) = 0.000000; -NODES[8101](VELOCITY_X,0) = 0.000000; -NODES[8101](VELOCITY_Y,0) = 0.000000; -NODES[8101](VELOCITY_Z,0) = 0.000000; -NODES[8107](VELOCITY_X,0) = 0.000000; -NODES[8107](VELOCITY_Y,0) = 0.000000; -NODES[8107](VELOCITY_Z,0) = 0.000000; -NODES[8108](VELOCITY_X,0) = 0.000000; -NODES[8108](VELOCITY_Y,0) = 0.000000; -NODES[8108](VELOCITY_Z,0) = 0.000000; -NODES[8113](VELOCITY_X,0) = 0.000000; -NODES[8113](VELOCITY_Y,0) = 0.000000; -NODES[8113](VELOCITY_Z,0) = 0.000000; -NODES[8118](VELOCITY_X,0) = 0.000000; -NODES[8118](VELOCITY_Y,0) = 0.000000; -NODES[8118](VELOCITY_Z,0) = 0.000000; -NODES[8119](VELOCITY_X,0) = 0.000000; -NODES[8119](VELOCITY_Y,0) = 0.000000; -NODES[8119](VELOCITY_Z,0) = 0.000000; -NODES[8123](VELOCITY_X,0) = 0.000000; -NODES[8123](VELOCITY_Y,0) = 0.000000; -NODES[8123](VELOCITY_Z,0) = 0.000000; -NODES[8126](VELOCITY_X,0) = 0.000000; -NODES[8126](VELOCITY_Y,0) = 0.000000; -NODES[8126](VELOCITY_Z,0) = 0.000000; -NODES[8127](VELOCITY_X,0) = 0.000000; -NODES[8127](VELOCITY_Y,0) = 0.000000; -NODES[8127](VELOCITY_Z,0) = 0.000000; -NODES[8129](VELOCITY_X,0) = 0.000000; -NODES[8129](VELOCITY_Y,0) = 0.000000; -NODES[8129](VELOCITY_Z,0) = 0.000000; -NODES[8130](VELOCITY_X,0) = 0.000000; -NODES[8130](VELOCITY_Y,0) = 0.000000; -NODES[8130](VELOCITY_Z,0) = 0.000000; -NODES[8131](VELOCITY_X,0) = 0.000000; -NODES[8131](VELOCITY_Y,0) = 0.000000; -NODES[8131](VELOCITY_Z,0) = 0.000000; -NODES[8135](VELOCITY_X,0) = 0.000000; -NODES[8135](VELOCITY_Y,0) = 0.000000; -NODES[8135](VELOCITY_Z,0) = 0.000000; -NODES[8145](VELOCITY_X,0) = 0.000000; -NODES[8145](VELOCITY_Y,0) = 0.000000; -NODES[8145](VELOCITY_Z,0) = 0.000000; -NODES[8146](VELOCITY_X,0) = 0.000000; -NODES[8146](VELOCITY_Y,0) = 0.000000; -NODES[8146](VELOCITY_Z,0) = 0.000000; -NODES[8150](VELOCITY_X,0) = 0.000000; -NODES[8150](VELOCITY_Y,0) = 0.000000; -NODES[8150](VELOCITY_Z,0) = 0.000000; -NODES[8159](VELOCITY_X,0) = 0.000000; -NODES[8159](VELOCITY_Y,0) = 0.000000; -NODES[8159](VELOCITY_Z,0) = 0.000000; -NODES[8167](VELOCITY_X,0) = 0.000000; -NODES[8167](VELOCITY_Y,0) = 0.000000; -NODES[8167](VELOCITY_Z,0) = 0.000000; -NODES[8168](VELOCITY_X,0) = 0.000000; -NODES[8168](VELOCITY_Y,0) = 0.000000; -NODES[8168](VELOCITY_Z,0) = 0.000000; -NODES[8171](VELOCITY_X,0) = 0.000000; -NODES[8171](VELOCITY_Y,0) = 0.000000; -NODES[8171](VELOCITY_Z,0) = 0.000000; -NODES[8172](VELOCITY_X,0) = 0.000000; -NODES[8172](VELOCITY_Y,0) = 0.000000; -NODES[8172](VELOCITY_Z,0) = 0.000000; -NODES[8173](VELOCITY_X,0) = 0.000000; -NODES[8173](VELOCITY_Y,0) = 0.000000; -NODES[8173](VELOCITY_Z,0) = 0.000000; -NODES[8175](VELOCITY_X,0) = 0.000000; -NODES[8175](VELOCITY_Y,0) = 0.000000; -NODES[8175](VELOCITY_Z,0) = 0.000000; -NODES[8177](VELOCITY_X,0) = 0.000000; -NODES[8177](VELOCITY_Y,0) = 0.000000; -NODES[8177](VELOCITY_Z,0) = 0.000000; -NODES[8179](VELOCITY_X,0) = 0.000000; -NODES[8179](VELOCITY_Y,0) = 0.000000; -NODES[8179](VELOCITY_Z,0) = 0.000000; -NODES[8183](VELOCITY_X,0) = 0.000000; -NODES[8183](VELOCITY_Y,0) = 0.000000; -NODES[8183](VELOCITY_Z,0) = 0.000000; -NODES[8186](VELOCITY_X,0) = 0.000000; -NODES[8186](VELOCITY_Y,0) = 0.000000; -NODES[8186](VELOCITY_Z,0) = 0.000000; -NODES[8191](VELOCITY_X,0) = 0.000000; -NODES[8191](VELOCITY_Y,0) = 0.000000; -NODES[8191](VELOCITY_Z,0) = 0.000000; -NODES[8200](VELOCITY_X,0) = 0.000000; -NODES[8200](VELOCITY_Y,0) = 0.000000; -NODES[8200](VELOCITY_Z,0) = 0.000000; -NODES[8214](VELOCITY_X,0) = 0.000000; -NODES[8214](VELOCITY_Y,0) = 0.000000; -NODES[8214](VELOCITY_Z,0) = 0.000000; -NODES[8215](VELOCITY_X,0) = 0.000000; -NODES[8215](VELOCITY_Y,0) = 0.000000; -NODES[8215](VELOCITY_Z,0) = 0.000000; -NODES[8229](VELOCITY_X,0) = 0.000000; -NODES[8229](VELOCITY_Y,0) = 0.000000; -NODES[8229](VELOCITY_Z,0) = 0.000000; -NODES[8234](VELOCITY_X,0) = 0.000000; -NODES[8234](VELOCITY_Y,0) = 0.000000; -NODES[8234](VELOCITY_Z,0) = 0.000000; -NODES[8235](VELOCITY_X,0) = 0.000000; -NODES[8235](VELOCITY_Y,0) = 0.000000; -NODES[8235](VELOCITY_Z,0) = 0.000000; -NODES[8236](VELOCITY_X,0) = 0.000000; -NODES[8236](VELOCITY_Y,0) = 0.000000; -NODES[8236](VELOCITY_Z,0) = 0.000000; -NODES[8237](VELOCITY_X,0) = 0.000000; -NODES[8237](VELOCITY_Y,0) = 0.000000; -NODES[8237](VELOCITY_Z,0) = 0.000000; -NODES[8238](VELOCITY_X,0) = 0.000000; -NODES[8238](VELOCITY_Y,0) = 0.000000; -NODES[8238](VELOCITY_Z,0) = 0.000000; -NODES[8239](VELOCITY_X,0) = 0.000000; -NODES[8239](VELOCITY_Y,0) = 0.000000; -NODES[8239](VELOCITY_Z,0) = 0.000000; -NODES[8240](VELOCITY_X,0) = 0.000000; -NODES[8240](VELOCITY_Y,0) = 0.000000; -NODES[8240](VELOCITY_Z,0) = 0.000000; -NODES[8241](VELOCITY_X,0) = 0.000000; -NODES[8241](VELOCITY_Y,0) = 0.000000; -NODES[8241](VELOCITY_Z,0) = 0.000000; -NODES[8242](VELOCITY_X,0) = 0.000000; -NODES[8242](VELOCITY_Y,0) = 0.000000; -NODES[8242](VELOCITY_Z,0) = 0.000000; -NODES[8248](VELOCITY_X,0) = 0.000000; -NODES[8248](VELOCITY_Y,0) = 0.000000; -NODES[8248](VELOCITY_Z,0) = 0.000000; -NODES[8253](VELOCITY_X,0) = 0.000000; -NODES[8253](VELOCITY_Y,0) = 0.000000; -NODES[8253](VELOCITY_Z,0) = 0.000000; -NODES[8254](VELOCITY_X,0) = 0.000000; -NODES[8254](VELOCITY_Y,0) = 0.000000; -NODES[8254](VELOCITY_Z,0) = 0.000000; -NODES[8255](VELOCITY_X,0) = 0.000000; -NODES[8255](VELOCITY_Y,0) = 0.000000; -NODES[8255](VELOCITY_Z,0) = 0.000000; -NODES[8262](VELOCITY_X,0) = 0.000000; -NODES[8262](VELOCITY_Y,0) = 0.000000; -NODES[8262](VELOCITY_Z,0) = 0.000000; -NODES[8263](VELOCITY_X,0) = 0.000000; -NODES[8263](VELOCITY_Y,0) = 0.000000; -NODES[8263](VELOCITY_Z,0) = 0.000000; -NODES[8264](VELOCITY_X,0) = 0.000000; -NODES[8264](VELOCITY_Y,0) = 0.000000; -NODES[8264](VELOCITY_Z,0) = 0.000000; -NODES[8267](VELOCITY_X,0) = 0.000000; -NODES[8267](VELOCITY_Y,0) = 0.000000; -NODES[8267](VELOCITY_Z,0) = 0.000000; -NODES[8275](VELOCITY_X,0) = 0.000000; -NODES[8275](VELOCITY_Y,0) = 0.000000; -NODES[8275](VELOCITY_Z,0) = 0.000000; -NODES[8277](VELOCITY_X,0) = 0.000000; -NODES[8277](VELOCITY_Y,0) = 0.000000; -NODES[8277](VELOCITY_Z,0) = 0.000000; -NODES[8278](VELOCITY_X,0) = 0.000000; -NODES[8278](VELOCITY_Y,0) = 0.000000; -NODES[8278](VELOCITY_Z,0) = 0.000000; -NODES[8279](VELOCITY_X,0) = 0.000000; -NODES[8279](VELOCITY_Y,0) = 0.000000; -NODES[8279](VELOCITY_Z,0) = 0.000000; -NODES[8280](VELOCITY_X,0) = 0.000000; -NODES[8280](VELOCITY_Y,0) = 0.000000; -NODES[8280](VELOCITY_Z,0) = 0.000000; -NODES[8285](VELOCITY_X,0) = 0.000000; -NODES[8285](VELOCITY_Y,0) = 0.000000; -NODES[8285](VELOCITY_Z,0) = 0.000000; -NODES[8286](VELOCITY_X,0) = 0.000000; -NODES[8286](VELOCITY_Y,0) = 0.000000; -NODES[8286](VELOCITY_Z,0) = 0.000000; -NODES[8287](VELOCITY_X,0) = 0.000000; -NODES[8287](VELOCITY_Y,0) = 0.000000; -NODES[8287](VELOCITY_Z,0) = 0.000000; -NODES[8293](VELOCITY_X,0) = 0.000000; -NODES[8293](VELOCITY_Y,0) = 0.000000; -NODES[8293](VELOCITY_Z,0) = 0.000000; -NODES[8301](VELOCITY_X,0) = 0.000000; -NODES[8301](VELOCITY_Y,0) = 0.000000; -NODES[8301](VELOCITY_Z,0) = 0.000000; -NODES[8313](VELOCITY_X,0) = 0.000000; -NODES[8313](VELOCITY_Y,0) = 0.000000; -NODES[8313](VELOCITY_Z,0) = 0.000000; -NODES[8315](VELOCITY_X,0) = 0.000000; -NODES[8315](VELOCITY_Y,0) = 0.000000; -NODES[8315](VELOCITY_Z,0) = 0.000000; -NODES[8316](VELOCITY_X,0) = 0.000000; -NODES[8316](VELOCITY_Y,0) = 0.000000; -NODES[8316](VELOCITY_Z,0) = 0.000000; -NODES[8317](VELOCITY_X,0) = 0.000000; -NODES[8317](VELOCITY_Y,0) = 0.000000; -NODES[8317](VELOCITY_Z,0) = 0.000000; -NODES[8319](VELOCITY_X,0) = 0.000000; -NODES[8319](VELOCITY_Y,0) = 0.000000; -NODES[8319](VELOCITY_Z,0) = 0.000000; -NODES[8320](VELOCITY_X,0) = 0.000000; -NODES[8320](VELOCITY_Y,0) = 0.000000; -NODES[8320](VELOCITY_Z,0) = 0.000000; -NODES[8328](VELOCITY_X,0) = 0.000000; -NODES[8328](VELOCITY_Y,0) = 0.000000; -NODES[8328](VELOCITY_Z,0) = 0.000000; -NODES[8352](VELOCITY_X,0) = 0.000000; -NODES[8352](VELOCITY_Y,0) = 0.000000; -NODES[8352](VELOCITY_Z,0) = 0.000000; -NODES[8356](VELOCITY_X,0) = 0.000000; -NODES[8356](VELOCITY_Y,0) = 0.000000; -NODES[8356](VELOCITY_Z,0) = 0.000000; -NODES[8357](VELOCITY_X,0) = 0.000000; -NODES[8357](VELOCITY_Y,0) = 0.000000; -NODES[8357](VELOCITY_Z,0) = 0.000000; -NODES[8363](VELOCITY_X,0) = 0.000000; -NODES[8363](VELOCITY_Y,0) = 0.000000; -NODES[8363](VELOCITY_Z,0) = 0.000000; -NODES[8371](VELOCITY_X,0) = 0.000000; -NODES[8371](VELOCITY_Y,0) = 0.000000; -NODES[8371](VELOCITY_Z,0) = 0.000000; -NODES[8377](VELOCITY_X,0) = 0.000000; -NODES[8377](VELOCITY_Y,0) = 0.000000; -NODES[8377](VELOCITY_Z,0) = 0.000000; -NODES[8390](VELOCITY_X,0) = 0.000000; -NODES[8390](VELOCITY_Y,0) = 0.000000; -NODES[8390](VELOCITY_Z,0) = 0.000000; -NODES[8391](VELOCITY_X,0) = 0.000000; -NODES[8391](VELOCITY_Y,0) = 0.000000; -NODES[8391](VELOCITY_Z,0) = 0.000000; -NODES[8392](VELOCITY_X,0) = 0.000000; -NODES[8392](VELOCITY_Y,0) = 0.000000; -NODES[8392](VELOCITY_Z,0) = 0.000000; -NODES[8393](VELOCITY_X,0) = 0.000000; -NODES[8393](VELOCITY_Y,0) = 0.000000; -NODES[8393](VELOCITY_Z,0) = 0.000000; -NODES[8394](VELOCITY_X,0) = 0.000000; -NODES[8394](VELOCITY_Y,0) = 0.000000; -NODES[8394](VELOCITY_Z,0) = 0.000000; -NODES[8400](VELOCITY_X,0) = 0.000000; -NODES[8400](VELOCITY_Y,0) = 0.000000; -NODES[8400](VELOCITY_Z,0) = 0.000000; -NODES[8401](VELOCITY_X,0) = 0.000000; -NODES[8401](VELOCITY_Y,0) = 0.000000; -NODES[8401](VELOCITY_Z,0) = 0.000000; -NODES[8403](VELOCITY_X,0) = 0.000000; -NODES[8403](VELOCITY_Y,0) = 0.000000; -NODES[8403](VELOCITY_Z,0) = 0.000000; -NODES[8407](VELOCITY_X,0) = 0.000000; -NODES[8407](VELOCITY_Y,0) = 0.000000; -NODES[8407](VELOCITY_Z,0) = 0.000000; -NODES[8408](VELOCITY_X,0) = 0.000000; -NODES[8408](VELOCITY_Y,0) = 0.000000; -NODES[8408](VELOCITY_Z,0) = 0.000000; -NODES[8419](VELOCITY_X,0) = 0.000000; -NODES[8419](VELOCITY_Y,0) = 0.000000; -NODES[8419](VELOCITY_Z,0) = 0.000000; -NODES[8420](VELOCITY_X,0) = 0.000000; -NODES[8420](VELOCITY_Y,0) = 0.000000; -NODES[8420](VELOCITY_Z,0) = 0.000000; -NODES[8421](VELOCITY_X,0) = 0.000000; -NODES[8421](VELOCITY_Y,0) = 0.000000; -NODES[8421](VELOCITY_Z,0) = 0.000000; -NODES[8422](VELOCITY_X,0) = 0.000000; -NODES[8422](VELOCITY_Y,0) = 0.000000; -NODES[8422](VELOCITY_Z,0) = 0.000000; -NODES[8434](VELOCITY_X,0) = 0.000000; -NODES[8434](VELOCITY_Y,0) = 0.000000; -NODES[8434](VELOCITY_Z,0) = 0.000000; -NODES[8435](VELOCITY_X,0) = 0.000000; -NODES[8435](VELOCITY_Y,0) = 0.000000; -NODES[8435](VELOCITY_Z,0) = 0.000000; -NODES[8436](VELOCITY_X,0) = 0.000000; -NODES[8436](VELOCITY_Y,0) = 0.000000; -NODES[8436](VELOCITY_Z,0) = 0.000000; -NODES[8443](VELOCITY_X,0) = 0.000000; -NODES[8443](VELOCITY_Y,0) = 0.000000; -NODES[8443](VELOCITY_Z,0) = 0.000000; -NODES[8445](VELOCITY_X,0) = 0.000000; -NODES[8445](VELOCITY_Y,0) = 0.000000; -NODES[8445](VELOCITY_Z,0) = 0.000000; -NODES[8454](VELOCITY_X,0) = 0.000000; -NODES[8454](VELOCITY_Y,0) = 0.000000; -NODES[8454](VELOCITY_Z,0) = 0.000000; -NODES[8456](VELOCITY_X,0) = 0.000000; -NODES[8456](VELOCITY_Y,0) = 0.000000; -NODES[8456](VELOCITY_Z,0) = 0.000000; -NODES[8472](VELOCITY_X,0) = 0.000000; -NODES[8472](VELOCITY_Y,0) = 0.000000; -NODES[8472](VELOCITY_Z,0) = 0.000000; -NODES[8476](VELOCITY_X,0) = 0.000000; -NODES[8476](VELOCITY_Y,0) = 0.000000; -NODES[8476](VELOCITY_Z,0) = 0.000000; -NODES[8480](VELOCITY_X,0) = 0.000000; -NODES[8480](VELOCITY_Y,0) = 0.000000; -NODES[8480](VELOCITY_Z,0) = 0.000000; -NODES[8481](VELOCITY_X,0) = 0.000000; -NODES[8481](VELOCITY_Y,0) = 0.000000; -NODES[8481](VELOCITY_Z,0) = 0.000000; -NODES[8482](VELOCITY_X,0) = 0.000000; -NODES[8482](VELOCITY_Y,0) = 0.000000; -NODES[8482](VELOCITY_Z,0) = 0.000000; -NODES[8490](VELOCITY_X,0) = 0.000000; -NODES[8490](VELOCITY_Y,0) = 0.000000; -NODES[8490](VELOCITY_Z,0) = 0.000000; -NODES[8504](VELOCITY_X,0) = 0.000000; -NODES[8504](VELOCITY_Y,0) = 0.000000; -NODES[8504](VELOCITY_Z,0) = 0.000000; -NODES[8508](VELOCITY_X,0) = 0.000000; -NODES[8508](VELOCITY_Y,0) = 0.000000; -NODES[8508](VELOCITY_Z,0) = 0.000000; -NODES[8513](VELOCITY_X,0) = 0.000000; -NODES[8513](VELOCITY_Y,0) = 0.000000; -NODES[8513](VELOCITY_Z,0) = 0.000000; -NODES[8516](VELOCITY_X,0) = 0.000000; -NODES[8516](VELOCITY_Y,0) = 0.000000; -NODES[8516](VELOCITY_Z,0) = 0.000000; -NODES[8521](VELOCITY_X,0) = 0.000000; -NODES[8521](VELOCITY_Y,0) = 0.000000; -NODES[8521](VELOCITY_Z,0) = 0.000000; -NODES[8526](VELOCITY_X,0) = 0.000000; -NODES[8526](VELOCITY_Y,0) = 0.000000; -NODES[8526](VELOCITY_Z,0) = 0.000000; -NODES[8527](VELOCITY_X,0) = 0.000000; -NODES[8527](VELOCITY_Y,0) = 0.000000; -NODES[8527](VELOCITY_Z,0) = 0.000000; -NODES[8528](VELOCITY_X,0) = 0.000000; -NODES[8528](VELOCITY_Y,0) = 0.000000; -NODES[8528](VELOCITY_Z,0) = 0.000000; -NODES[8539](VELOCITY_X,0) = 0.000000; -NODES[8539](VELOCITY_Y,0) = 0.000000; -NODES[8539](VELOCITY_Z,0) = 0.000000; -NODES[8544](VELOCITY_X,0) = 0.000000; -NODES[8544](VELOCITY_Y,0) = 0.000000; -NODES[8544](VELOCITY_Z,0) = 0.000000; -NODES[8553](VELOCITY_X,0) = 0.000000; -NODES[8553](VELOCITY_Y,0) = 0.000000; -NODES[8553](VELOCITY_Z,0) = 0.000000; -NODES[8554](VELOCITY_X,0) = 0.000000; -NODES[8554](VELOCITY_Y,0) = 0.000000; -NODES[8554](VELOCITY_Z,0) = 0.000000; -NODES[8555](VELOCITY_X,0) = 0.000000; -NODES[8555](VELOCITY_Y,0) = 0.000000; -NODES[8555](VELOCITY_Z,0) = 0.000000; -NODES[8557](VELOCITY_X,0) = 0.000000; -NODES[8557](VELOCITY_Y,0) = 0.000000; -NODES[8557](VELOCITY_Z,0) = 0.000000; -NODES[8558](VELOCITY_X,0) = 0.000000; -NODES[8558](VELOCITY_Y,0) = 0.000000; -NODES[8558](VELOCITY_Z,0) = 0.000000; -NODES[8559](VELOCITY_X,0) = 0.000000; -NODES[8559](VELOCITY_Y,0) = 0.000000; -NODES[8559](VELOCITY_Z,0) = 0.000000; -NODES[8560](VELOCITY_X,0) = 0.000000; -NODES[8560](VELOCITY_Y,0) = 0.000000; -NODES[8560](VELOCITY_Z,0) = 0.000000; -NODES[8561](VELOCITY_X,0) = 0.000000; -NODES[8561](VELOCITY_Y,0) = 0.000000; -NODES[8561](VELOCITY_Z,0) = 0.000000; -NODES[8562](VELOCITY_X,0) = 0.000000; -NODES[8562](VELOCITY_Y,0) = 0.000000; -NODES[8562](VELOCITY_Z,0) = 0.000000; -NODES[8563](VELOCITY_X,0) = 0.000000; -NODES[8563](VELOCITY_Y,0) = 0.000000; -NODES[8563](VELOCITY_Z,0) = 0.000000; -NODES[8564](VELOCITY_X,0) = 0.000000; -NODES[8564](VELOCITY_Y,0) = 0.000000; -NODES[8564](VELOCITY_Z,0) = 0.000000; -NODES[8565](VELOCITY_X,0) = 0.000000; -NODES[8565](VELOCITY_Y,0) = 0.000000; -NODES[8565](VELOCITY_Z,0) = 0.000000; -NODES[8571](VELOCITY_X,0) = 0.000000; -NODES[8571](VELOCITY_Y,0) = 0.000000; -NODES[8571](VELOCITY_Z,0) = 0.000000; -NODES[8572](VELOCITY_X,0) = 0.000000; -NODES[8572](VELOCITY_Y,0) = 0.000000; -NODES[8572](VELOCITY_Z,0) = 0.000000; -NODES[8577](VELOCITY_X,0) = 0.000000; -NODES[8577](VELOCITY_Y,0) = 0.000000; -NODES[8577](VELOCITY_Z,0) = 0.000000; -NODES[8579](VELOCITY_X,0) = 0.000000; -NODES[8579](VELOCITY_Y,0) = 0.000000; -NODES[8579](VELOCITY_Z,0) = 0.000000; -NODES[8583](VELOCITY_X,0) = 0.000000; -NODES[8583](VELOCITY_Y,0) = 0.000000; -NODES[8583](VELOCITY_Z,0) = 0.000000; -NODES[8600](VELOCITY_X,0) = 0.000000; -NODES[8600](VELOCITY_Y,0) = 0.000000; -NODES[8600](VELOCITY_Z,0) = 0.000000; -NODES[8601](VELOCITY_X,0) = 0.000000; -NODES[8601](VELOCITY_Y,0) = 0.000000; -NODES[8601](VELOCITY_Z,0) = 0.000000; -NODES[8602](VELOCITY_X,0) = 0.000000; -NODES[8602](VELOCITY_Y,0) = 0.000000; -NODES[8602](VELOCITY_Z,0) = 0.000000; -NODES[8609](VELOCITY_X,0) = 0.000000; -NODES[8609](VELOCITY_Y,0) = 0.000000; -NODES[8609](VELOCITY_Z,0) = 0.000000; -NODES[8611](VELOCITY_X,0) = 0.000000; -NODES[8611](VELOCITY_Y,0) = 0.000000; -NODES[8611](VELOCITY_Z,0) = 0.000000; -NODES[8617](VELOCITY_X,0) = 0.000000; -NODES[8617](VELOCITY_Y,0) = 0.000000; -NODES[8617](VELOCITY_Z,0) = 0.000000; -NODES[8624](VELOCITY_X,0) = 0.000000; -NODES[8624](VELOCITY_Y,0) = 0.000000; -NODES[8624](VELOCITY_Z,0) = 0.000000; -NODES[8625](VELOCITY_X,0) = 0.000000; -NODES[8625](VELOCITY_Y,0) = 0.000000; -NODES[8625](VELOCITY_Z,0) = 0.000000; -NODES[8626](VELOCITY_X,0) = 0.000000; -NODES[8626](VELOCITY_Y,0) = 0.000000; -NODES[8626](VELOCITY_Z,0) = 0.000000; -NODES[8630](VELOCITY_X,0) = 0.000000; -NODES[8630](VELOCITY_Y,0) = 0.000000; -NODES[8630](VELOCITY_Z,0) = 0.000000; -NODES[8632](VELOCITY_X,0) = 0.000000; -NODES[8632](VELOCITY_Y,0) = 0.000000; -NODES[8632](VELOCITY_Z,0) = 0.000000; -NODES[8637](VELOCITY_X,0) = 0.000000; -NODES[8637](VELOCITY_Y,0) = 0.000000; -NODES[8637](VELOCITY_Z,0) = 0.000000; -NODES[8652](VELOCITY_X,0) = 0.000000; -NODES[8652](VELOCITY_Y,0) = 0.000000; -NODES[8652](VELOCITY_Z,0) = 0.000000; -NODES[8662](VELOCITY_X,0) = 0.000000; -NODES[8662](VELOCITY_Y,0) = 0.000000; -NODES[8662](VELOCITY_Z,0) = 0.000000; -NODES[8679](VELOCITY_X,0) = 0.000000; -NODES[8679](VELOCITY_Y,0) = 0.000000; -NODES[8679](VELOCITY_Z,0) = 0.000000; -NODES[8681](VELOCITY_X,0) = 0.000000; -NODES[8681](VELOCITY_Y,0) = 0.000000; -NODES[8681](VELOCITY_Z,0) = 0.000000; -NODES[8690](VELOCITY_X,0) = 0.000000; -NODES[8690](VELOCITY_Y,0) = 0.000000; -NODES[8690](VELOCITY_Z,0) = 0.000000; -NODES[8697](VELOCITY_X,0) = 0.000000; -NODES[8697](VELOCITY_Y,0) = 0.000000; -NODES[8697](VELOCITY_Z,0) = 0.000000; -NODES[8700](VELOCITY_X,0) = 0.000000; -NODES[8700](VELOCITY_Y,0) = 0.000000; -NODES[8700](VELOCITY_Z,0) = 0.000000; -NODES[8701](VELOCITY_X,0) = 0.000000; -NODES[8701](VELOCITY_Y,0) = 0.000000; -NODES[8701](VELOCITY_Z,0) = 0.000000; -NODES[8703](VELOCITY_X,0) = 0.000000; -NODES[8703](VELOCITY_Y,0) = 0.000000; -NODES[8703](VELOCITY_Z,0) = 0.000000; -NODES[8705](VELOCITY_X,0) = 0.000000; -NODES[8705](VELOCITY_Y,0) = 0.000000; -NODES[8705](VELOCITY_Z,0) = 0.000000; -NODES[8713](VELOCITY_X,0) = 0.000000; -NODES[8713](VELOCITY_Y,0) = 0.000000; -NODES[8713](VELOCITY_Z,0) = 0.000000; -NODES[8715](VELOCITY_X,0) = 0.000000; -NODES[8715](VELOCITY_Y,0) = 0.000000; -NODES[8715](VELOCITY_Z,0) = 0.000000; -NODES[8716](VELOCITY_X,0) = 0.000000; -NODES[8716](VELOCITY_Y,0) = 0.000000; -NODES[8716](VELOCITY_Z,0) = 0.000000; -NODES[8717](VELOCITY_X,0) = 0.000000; -NODES[8717](VELOCITY_Y,0) = 0.000000; -NODES[8717](VELOCITY_Z,0) = 0.000000; -NODES[8719](VELOCITY_X,0) = 0.000000; -NODES[8719](VELOCITY_Y,0) = 0.000000; -NODES[8719](VELOCITY_Z,0) = 0.000000; -NODES[8724](VELOCITY_X,0) = 0.000000; -NODES[8724](VELOCITY_Y,0) = 0.000000; -NODES[8724](VELOCITY_Z,0) = 0.000000; -NODES[8725](VELOCITY_X,0) = 0.000000; -NODES[8725](VELOCITY_Y,0) = 0.000000; -NODES[8725](VELOCITY_Z,0) = 0.000000; -NODES[8730](VELOCITY_X,0) = 0.000000; -NODES[8730](VELOCITY_Y,0) = 0.000000; -NODES[8730](VELOCITY_Z,0) = 0.000000; -NODES[8732](VELOCITY_X,0) = 0.000000; -NODES[8732](VELOCITY_Y,0) = 0.000000; -NODES[8732](VELOCITY_Z,0) = 0.000000; -NODES[8733](VELOCITY_X,0) = 0.000000; -NODES[8733](VELOCITY_Y,0) = 0.000000; -NODES[8733](VELOCITY_Z,0) = 0.000000; -NODES[8738](VELOCITY_X,0) = 0.000000; -NODES[8738](VELOCITY_Y,0) = 0.000000; -NODES[8738](VELOCITY_Z,0) = 0.000000; -NODES[8744](VELOCITY_X,0) = 0.000000; -NODES[8744](VELOCITY_Y,0) = 0.000000; -NODES[8744](VELOCITY_Z,0) = 0.000000; -NODES[8760](VELOCITY_X,0) = 0.000000; -NODES[8760](VELOCITY_Y,0) = 0.000000; -NODES[8760](VELOCITY_Z,0) = 0.000000; -NODES[8761](VELOCITY_X,0) = 0.000000; -NODES[8761](VELOCITY_Y,0) = 0.000000; -NODES[8761](VELOCITY_Z,0) = 0.000000; -NODES[8762](VELOCITY_X,0) = 0.000000; -NODES[8762](VELOCITY_Y,0) = 0.000000; -NODES[8762](VELOCITY_Z,0) = 0.000000; -NODES[8780](VELOCITY_X,0) = 0.000000; -NODES[8780](VELOCITY_Y,0) = 0.000000; -NODES[8780](VELOCITY_Z,0) = 0.000000; -NODES[8782](VELOCITY_X,0) = 0.000000; -NODES[8782](VELOCITY_Y,0) = 0.000000; -NODES[8782](VELOCITY_Z,0) = 0.000000; -NODES[8787](VELOCITY_X,0) = 0.000000; -NODES[8787](VELOCITY_Y,0) = 0.000000; -NODES[8787](VELOCITY_Z,0) = 0.000000; -NODES[8802](VELOCITY_X,0) = 0.000000; -NODES[8802](VELOCITY_Y,0) = 0.000000; -NODES[8802](VELOCITY_Z,0) = 0.000000; -NODES[8812](VELOCITY_X,0) = 0.000000; -NODES[8812](VELOCITY_Y,0) = 0.000000; -NODES[8812](VELOCITY_Z,0) = 0.000000; -NODES[8824](VELOCITY_X,0) = 0.000000; -NODES[8824](VELOCITY_Y,0) = 0.000000; -NODES[8824](VELOCITY_Z,0) = 0.000000; -NODES[8825](VELOCITY_X,0) = 0.000000; -NODES[8825](VELOCITY_Y,0) = 0.000000; -NODES[8825](VELOCITY_Z,0) = 0.000000; -NODES[8826](VELOCITY_X,0) = 0.000000; -NODES[8826](VELOCITY_Y,0) = 0.000000; -NODES[8826](VELOCITY_Z,0) = 0.000000; -NODES[8827](VELOCITY_X,0) = 0.000000; -NODES[8827](VELOCITY_Y,0) = 0.000000; -NODES[8827](VELOCITY_Z,0) = 0.000000; -NODES[8828](VELOCITY_X,0) = 0.000000; -NODES[8828](VELOCITY_Y,0) = 0.000000; -NODES[8828](VELOCITY_Z,0) = 0.000000; -NODES[8836](VELOCITY_X,0) = 0.000000; -NODES[8836](VELOCITY_Y,0) = 0.000000; -NODES[8836](VELOCITY_Z,0) = 0.000000; -NODES[8853](VELOCITY_X,0) = 0.000000; -NODES[8853](VELOCITY_Y,0) = 0.000000; -NODES[8853](VELOCITY_Z,0) = 0.000000; -NODES[8856](VELOCITY_X,0) = 0.000000; -NODES[8856](VELOCITY_Y,0) = 0.000000; -NODES[8856](VELOCITY_Z,0) = 0.000000; -NODES[8857](VELOCITY_X,0) = 0.000000; -NODES[8857](VELOCITY_Y,0) = 0.000000; -NODES[8857](VELOCITY_Z,0) = 0.000000; -NODES[8862](VELOCITY_X,0) = 0.000000; -NODES[8862](VELOCITY_Y,0) = 0.000000; -NODES[8862](VELOCITY_Z,0) = 0.000000; -NODES[8868](VELOCITY_X,0) = 0.000000; -NODES[8868](VELOCITY_Y,0) = 0.000000; -NODES[8868](VELOCITY_Z,0) = 0.000000; -NODES[8870](VELOCITY_X,0) = 0.000000; -NODES[8870](VELOCITY_Y,0) = 0.000000; -NODES[8870](VELOCITY_Z,0) = 0.000000; -NODES[8872](VELOCITY_X,0) = 0.000000; -NODES[8872](VELOCITY_Y,0) = 0.000000; -NODES[8872](VELOCITY_Z,0) = 0.000000; -NODES[8873](VELOCITY_X,0) = 0.000000; -NODES[8873](VELOCITY_Y,0) = 0.000000; -NODES[8873](VELOCITY_Z,0) = 0.000000; -NODES[8879](VELOCITY_X,0) = 0.000000; -NODES[8879](VELOCITY_Y,0) = 0.000000; -NODES[8879](VELOCITY_Z,0) = 0.000000; -NODES[8887](VELOCITY_X,0) = 0.000000; -NODES[8887](VELOCITY_Y,0) = 0.000000; -NODES[8887](VELOCITY_Z,0) = 0.000000; -NODES[8888](VELOCITY_X,0) = 0.000000; -NODES[8888](VELOCITY_Y,0) = 0.000000; -NODES[8888](VELOCITY_Z,0) = 0.000000; -NODES[8892](VELOCITY_X,0) = 0.000000; -NODES[8892](VELOCITY_Y,0) = 0.000000; -NODES[8892](VELOCITY_Z,0) = 0.000000; -NODES[8893](VELOCITY_X,0) = 0.000000; -NODES[8893](VELOCITY_Y,0) = 0.000000; -NODES[8893](VELOCITY_Z,0) = 0.000000; -NODES[8894](VELOCITY_X,0) = 0.000000; -NODES[8894](VELOCITY_Y,0) = 0.000000; -NODES[8894](VELOCITY_Z,0) = 0.000000; -NODES[8896](VELOCITY_X,0) = 0.000000; -NODES[8896](VELOCITY_Y,0) = 0.000000; -NODES[8896](VELOCITY_Z,0) = 0.000000; -NODES[8899](VELOCITY_X,0) = 0.000000; -NODES[8899](VELOCITY_Y,0) = 0.000000; -NODES[8899](VELOCITY_Z,0) = 0.000000; -NODES[8900](VELOCITY_X,0) = 0.000000; -NODES[8900](VELOCITY_Y,0) = 0.000000; -NODES[8900](VELOCITY_Z,0) = 0.000000; -NODES[8901](VELOCITY_X,0) = 0.000000; -NODES[8901](VELOCITY_Y,0) = 0.000000; -NODES[8901](VELOCITY_Z,0) = 0.000000; -NODES[8904](VELOCITY_X,0) = 0.000000; -NODES[8904](VELOCITY_Y,0) = 0.000000; -NODES[8904](VELOCITY_Z,0) = 0.000000; -NODES[8921](VELOCITY_X,0) = 0.000000; -NODES[8921](VELOCITY_Y,0) = 0.000000; -NODES[8921](VELOCITY_Z,0) = 0.000000; -NODES[8922](VELOCITY_X,0) = 0.000000; -NODES[8922](VELOCITY_Y,0) = 0.000000; -NODES[8922](VELOCITY_Z,0) = 0.000000; -NODES[8924](VELOCITY_X,0) = 0.000000; -NODES[8924](VELOCITY_Y,0) = 0.000000; -NODES[8924](VELOCITY_Z,0) = 0.000000; -NODES[8930](VELOCITY_X,0) = 0.000000; -NODES[8930](VELOCITY_Y,0) = 0.000000; -NODES[8930](VELOCITY_Z,0) = 0.000000; -NODES[8931](VELOCITY_X,0) = 0.000000; -NODES[8931](VELOCITY_Y,0) = 0.000000; -NODES[8931](VELOCITY_Z,0) = 0.000000; -NODES[8932](VELOCITY_X,0) = 0.000000; -NODES[8932](VELOCITY_Y,0) = 0.000000; -NODES[8932](VELOCITY_Z,0) = 0.000000; -NODES[8937](VELOCITY_X,0) = 0.000000; -NODES[8937](VELOCITY_Y,0) = 0.000000; -NODES[8937](VELOCITY_Z,0) = 0.000000; -NODES[8938](VELOCITY_X,0) = 0.000000; -NODES[8938](VELOCITY_Y,0) = 0.000000; -NODES[8938](VELOCITY_Z,0) = 0.000000; -NODES[8939](VELOCITY_X,0) = 0.000000; -NODES[8939](VELOCITY_Y,0) = 0.000000; -NODES[8939](VELOCITY_Z,0) = 0.000000; -NODES[8940](VELOCITY_X,0) = 0.000000; -NODES[8940](VELOCITY_Y,0) = 0.000000; -NODES[8940](VELOCITY_Z,0) = 0.000000; -NODES[8941](VELOCITY_X,0) = 0.000000; -NODES[8941](VELOCITY_Y,0) = 0.000000; -NODES[8941](VELOCITY_Z,0) = 0.000000; -NODES[8942](VELOCITY_X,0) = 0.000000; -NODES[8942](VELOCITY_Y,0) = 0.000000; -NODES[8942](VELOCITY_Z,0) = 0.000000; -NODES[8943](VELOCITY_X,0) = 0.000000; -NODES[8943](VELOCITY_Y,0) = 0.000000; -NODES[8943](VELOCITY_Z,0) = 0.000000; -NODES[8944](VELOCITY_X,0) = 0.000000; -NODES[8944](VELOCITY_Y,0) = 0.000000; -NODES[8944](VELOCITY_Z,0) = 0.000000; -NODES[8953](VELOCITY_X,0) = 0.000000; -NODES[8953](VELOCITY_Y,0) = 0.000000; -NODES[8953](VELOCITY_Z,0) = 0.000000; -NODES[8967](VELOCITY_X,0) = 0.000000; -NODES[8967](VELOCITY_Y,0) = 0.000000; -NODES[8967](VELOCITY_Z,0) = 0.000000; -NODES[8972](VELOCITY_X,0) = 0.000000; -NODES[8972](VELOCITY_Y,0) = 0.000000; -NODES[8972](VELOCITY_Z,0) = 0.000000; -NODES[8973](VELOCITY_X,0) = 0.000000; -NODES[8973](VELOCITY_Y,0) = 0.000000; -NODES[8973](VELOCITY_Z,0) = 0.000000; -NODES[8974](VELOCITY_X,0) = 0.000000; -NODES[8974](VELOCITY_Y,0) = 0.000000; -NODES[8974](VELOCITY_Z,0) = 0.000000; -NODES[8975](VELOCITY_X,0) = 0.000000; -NODES[8975](VELOCITY_Y,0) = 0.000000; -NODES[8975](VELOCITY_Z,0) = 0.000000; -NODES[8980](VELOCITY_X,0) = 0.000000; -NODES[8980](VELOCITY_Y,0) = 0.000000; -NODES[8980](VELOCITY_Z,0) = 0.000000; -NODES[8983](VELOCITY_X,0) = 0.000000; -NODES[8983](VELOCITY_Y,0) = 0.000000; -NODES[8983](VELOCITY_Z,0) = 0.000000; -NODES[8984](VELOCITY_X,0) = 0.000000; -NODES[8984](VELOCITY_Y,0) = 0.000000; -NODES[8984](VELOCITY_Z,0) = 0.000000; -NODES[8985](VELOCITY_X,0) = 0.000000; -NODES[8985](VELOCITY_Y,0) = 0.000000; -NODES[8985](VELOCITY_Z,0) = 0.000000; -NODES[8986](VELOCITY_X,0) = 0.000000; -NODES[8986](VELOCITY_Y,0) = 0.000000; -NODES[8986](VELOCITY_Z,0) = 0.000000; -NODES[8992](VELOCITY_X,0) = 0.000000; -NODES[8992](VELOCITY_Y,0) = 0.000000; -NODES[8992](VELOCITY_Z,0) = 0.000000; -NODES[8993](VELOCITY_X,0) = 0.000000; -NODES[8993](VELOCITY_Y,0) = 0.000000; -NODES[8993](VELOCITY_Z,0) = 0.000000; -NODES[9006](VELOCITY_X,0) = 0.000000; -NODES[9006](VELOCITY_Y,0) = 0.000000; -NODES[9006](VELOCITY_Z,0) = 0.000000; -NODES[9007](VELOCITY_X,0) = 0.000000; -NODES[9007](VELOCITY_Y,0) = 0.000000; -NODES[9007](VELOCITY_Z,0) = 0.000000; -NODES[9010](VELOCITY_X,0) = 0.000000; -NODES[9010](VELOCITY_Y,0) = 0.000000; -NODES[9010](VELOCITY_Z,0) = 0.000000; -NODES[9018](VELOCITY_X,0) = 0.000000; -NODES[9018](VELOCITY_Y,0) = 0.000000; -NODES[9018](VELOCITY_Z,0) = 0.000000; -NODES[9023](VELOCITY_X,0) = 0.000000; -NODES[9023](VELOCITY_Y,0) = 0.000000; -NODES[9023](VELOCITY_Z,0) = 0.000000; -NODES[9025](VELOCITY_X,0) = 0.000000; -NODES[9025](VELOCITY_Y,0) = 0.000000; -NODES[9025](VELOCITY_Z,0) = 0.000000; -NODES[9026](VELOCITY_X,0) = 0.000000; -NODES[9026](VELOCITY_Y,0) = 0.000000; -NODES[9026](VELOCITY_Z,0) = 0.000000; -NODES[9031](VELOCITY_X,0) = 0.000000; -NODES[9031](VELOCITY_Y,0) = 0.000000; -NODES[9031](VELOCITY_Z,0) = 0.000000; -NODES[9048](VELOCITY_X,0) = 0.000000; -NODES[9048](VELOCITY_Y,0) = 0.000000; -NODES[9048](VELOCITY_Z,0) = 0.000000; -NODES[9049](VELOCITY_X,0) = 0.000000; -NODES[9049](VELOCITY_Y,0) = 0.000000; -NODES[9049](VELOCITY_Z,0) = 0.000000; -NODES[9056](VELOCITY_X,0) = 0.000000; -NODES[9056](VELOCITY_Y,0) = 0.000000; -NODES[9056](VELOCITY_Z,0) = 0.000000; -NODES[9059](VELOCITY_X,0) = 0.000000; -NODES[9059](VELOCITY_Y,0) = 0.000000; -NODES[9059](VELOCITY_Z,0) = 0.000000; -NODES[9060](VELOCITY_X,0) = 0.000000; -NODES[9060](VELOCITY_Y,0) = 0.000000; -NODES[9060](VELOCITY_Z,0) = 0.000000; -NODES[9066](VELOCITY_X,0) = 0.000000; -NODES[9066](VELOCITY_Y,0) = 0.000000; -NODES[9066](VELOCITY_Z,0) = 0.000000; -NODES[9071](VELOCITY_X,0) = 0.000000; -NODES[9071](VELOCITY_Y,0) = 0.000000; -NODES[9071](VELOCITY_Z,0) = 0.000000; -NODES[9076](VELOCITY_X,0) = 0.000000; -NODES[9076](VELOCITY_Y,0) = 0.000000; -NODES[9076](VELOCITY_Z,0) = 0.000000; -NODES[9077](VELOCITY_X,0) = 0.000000; -NODES[9077](VELOCITY_Y,0) = 0.000000; -NODES[9077](VELOCITY_Z,0) = 0.000000; -NODES[9078](VELOCITY_X,0) = 0.000000; -NODES[9078](VELOCITY_Y,0) = 0.000000; -NODES[9078](VELOCITY_Z,0) = 0.000000; -NODES[9092](VELOCITY_X,0) = 0.000000; -NODES[9092](VELOCITY_Y,0) = 0.000000; -NODES[9092](VELOCITY_Z,0) = 0.000000; -NODES[9100](VELOCITY_X,0) = 0.000000; -NODES[9100](VELOCITY_Y,0) = 0.000000; -NODES[9100](VELOCITY_Z,0) = 0.000000; -NODES[9101](VELOCITY_X,0) = 0.000000; -NODES[9101](VELOCITY_Y,0) = 0.000000; -NODES[9101](VELOCITY_Z,0) = 0.000000; -NODES[9122](VELOCITY_X,0) = 0.000000; -NODES[9122](VELOCITY_Y,0) = 0.000000; -NODES[9122](VELOCITY_Z,0) = 0.000000; -NODES[9123](VELOCITY_X,0) = 0.000000; -NODES[9123](VELOCITY_Y,0) = 0.000000; -NODES[9123](VELOCITY_Z,0) = 0.000000; -NODES[9124](VELOCITY_X,0) = 0.000000; -NODES[9124](VELOCITY_Y,0) = 0.000000; -NODES[9124](VELOCITY_Z,0) = 0.000000; -NODES[9125](VELOCITY_X,0) = 0.000000; -NODES[9125](VELOCITY_Y,0) = 0.000000; -NODES[9125](VELOCITY_Z,0) = 0.000000; -NODES[9134](VELOCITY_X,0) = 0.000000; -NODES[9134](VELOCITY_Y,0) = 0.000000; -NODES[9134](VELOCITY_Z,0) = 0.000000; -NODES[9136](VELOCITY_X,0) = 0.000000; -NODES[9136](VELOCITY_Y,0) = 0.000000; -NODES[9136](VELOCITY_Z,0) = 0.000000; -NODES[9137](VELOCITY_X,0) = 0.000000; -NODES[9137](VELOCITY_Y,0) = 0.000000; -NODES[9137](VELOCITY_Z,0) = 0.000000; -NODES[9147](VELOCITY_X,0) = 0.000000; -NODES[9147](VELOCITY_Y,0) = 0.000000; -NODES[9147](VELOCITY_Z,0) = 0.000000; -NODES[9154](VELOCITY_X,0) = 0.000000; -NODES[9154](VELOCITY_Y,0) = 0.000000; -NODES[9154](VELOCITY_Z,0) = 0.000000; -NODES[9155](VELOCITY_X,0) = 0.000000; -NODES[9155](VELOCITY_Y,0) = 0.000000; -NODES[9155](VELOCITY_Z,0) = 0.000000; -NODES[9158](VELOCITY_X,0) = 0.000000; -NODES[9158](VELOCITY_Y,0) = 0.000000; -NODES[9158](VELOCITY_Z,0) = 0.000000; -NODES[9159](VELOCITY_X,0) = 0.000000; -NODES[9159](VELOCITY_Y,0) = 0.000000; -NODES[9159](VELOCITY_Z,0) = 0.000000; -NODES[9162](VELOCITY_X,0) = 0.000000; -NODES[9162](VELOCITY_Y,0) = 0.000000; -NODES[9162](VELOCITY_Z,0) = 0.000000; -NODES[9163](VELOCITY_X,0) = 0.000000; -NODES[9163](VELOCITY_Y,0) = 0.000000; -NODES[9163](VELOCITY_Z,0) = 0.000000; -NODES[9166](VELOCITY_X,0) = 0.000000; -NODES[9166](VELOCITY_Y,0) = 0.000000; -NODES[9166](VELOCITY_Z,0) = 0.000000; -NODES[9167](VELOCITY_X,0) = 0.000000; -NODES[9167](VELOCITY_Y,0) = 0.000000; -NODES[9167](VELOCITY_Z,0) = 0.000000; -NODES[9168](VELOCITY_X,0) = 0.000000; -NODES[9168](VELOCITY_Y,0) = 0.000000; -NODES[9168](VELOCITY_Z,0) = 0.000000; -NODES[9172](VELOCITY_X,0) = 0.000000; -NODES[9172](VELOCITY_Y,0) = 0.000000; -NODES[9172](VELOCITY_Z,0) = 0.000000; -NODES[9188](VELOCITY_X,0) = 0.000000; -NODES[9188](VELOCITY_Y,0) = 0.000000; -NODES[9188](VELOCITY_Z,0) = 0.000000; -NODES[9193](VELOCITY_X,0) = 0.000000; -NODES[9193](VELOCITY_Y,0) = 0.000000; -NODES[9193](VELOCITY_Z,0) = 0.000000; -NODES[9194](VELOCITY_X,0) = 0.000000; -NODES[9194](VELOCITY_Y,0) = 0.000000; -NODES[9194](VELOCITY_Z,0) = 0.000000; -NODES[9195](VELOCITY_X,0) = 0.000000; -NODES[9195](VELOCITY_Y,0) = 0.000000; -NODES[9195](VELOCITY_Z,0) = 0.000000; -NODES[9196](VELOCITY_X,0) = 0.000000; -NODES[9196](VELOCITY_Y,0) = 0.000000; -NODES[9196](VELOCITY_Z,0) = 0.000000; -NODES[9197](VELOCITY_X,0) = 0.000000; -NODES[9197](VELOCITY_Y,0) = 0.000000; -NODES[9197](VELOCITY_Z,0) = 0.000000; -NODES[9198](VELOCITY_X,0) = 0.000000; -NODES[9198](VELOCITY_Y,0) = 0.000000; -NODES[9198](VELOCITY_Z,0) = 0.000000; -NODES[9199](VELOCITY_X,0) = 0.000000; -NODES[9199](VELOCITY_Y,0) = 0.000000; -NODES[9199](VELOCITY_Z,0) = 0.000000; -NODES[9218](VELOCITY_X,0) = 0.000000; -NODES[9218](VELOCITY_Y,0) = 0.000000; -NODES[9218](VELOCITY_Z,0) = 0.000000; -NODES[9222](VELOCITY_X,0) = 0.000000; -NODES[9222](VELOCITY_Y,0) = 0.000000; -NODES[9222](VELOCITY_Z,0) = 0.000000; -NODES[9232](VELOCITY_X,0) = 0.000000; -NODES[9232](VELOCITY_Y,0) = 0.000000; -NODES[9232](VELOCITY_Z,0) = 0.000000; -NODES[9233](VELOCITY_X,0) = 0.000000; -NODES[9233](VELOCITY_Y,0) = 0.000000; -NODES[9233](VELOCITY_Z,0) = 0.000000; -NODES[9245](VELOCITY_X,0) = 0.000000; -NODES[9245](VELOCITY_Y,0) = 0.000000; -NODES[9245](VELOCITY_Z,0) = 0.000000; -NODES[9248](VELOCITY_X,0) = 0.000000; -NODES[9248](VELOCITY_Y,0) = 0.000000; -NODES[9248](VELOCITY_Z,0) = 0.000000; -NODES[9249](VELOCITY_X,0) = 0.000000; -NODES[9249](VELOCITY_Y,0) = 0.000000; -NODES[9249](VELOCITY_Z,0) = 0.000000; -NODES[9250](VELOCITY_X,0) = 0.000000; -NODES[9250](VELOCITY_Y,0) = 0.000000; -NODES[9250](VELOCITY_Z,0) = 0.000000; -NODES[9251](VELOCITY_X,0) = 0.000000; -NODES[9251](VELOCITY_Y,0) = 0.000000; -NODES[9251](VELOCITY_Z,0) = 0.000000; -NODES[9254](VELOCITY_X,0) = 0.000000; -NODES[9254](VELOCITY_Y,0) = 0.000000; -NODES[9254](VELOCITY_Z,0) = 0.000000; -NODES[9256](VELOCITY_X,0) = 0.000000; -NODES[9256](VELOCITY_Y,0) = 0.000000; -NODES[9256](VELOCITY_Z,0) = 0.000000; -NODES[9272](VELOCITY_X,0) = 0.000000; -NODES[9272](VELOCITY_Y,0) = 0.000000; -NODES[9272](VELOCITY_Z,0) = 0.000000; -NODES[9273](VELOCITY_X,0) = 0.000000; -NODES[9273](VELOCITY_Y,0) = 0.000000; -NODES[9273](VELOCITY_Z,0) = 0.000000; -NODES[9275](VELOCITY_X,0) = 0.000000; -NODES[9275](VELOCITY_Y,0) = 0.000000; -NODES[9275](VELOCITY_Z,0) = 0.000000; -NODES[9277](VELOCITY_X,0) = 0.000000; -NODES[9277](VELOCITY_Y,0) = 0.000000; -NODES[9277](VELOCITY_Z,0) = 0.000000; -NODES[9278](VELOCITY_X,0) = 0.000000; -NODES[9278](VELOCITY_Y,0) = 0.000000; -NODES[9278](VELOCITY_Z,0) = 0.000000; -NODES[9282](VELOCITY_X,0) = 0.000000; -NODES[9282](VELOCITY_Y,0) = 0.000000; -NODES[9282](VELOCITY_Z,0) = 0.000000; -NODES[9283](VELOCITY_X,0) = 0.000000; -NODES[9283](VELOCITY_Y,0) = 0.000000; -NODES[9283](VELOCITY_Z,0) = 0.000000; -NODES[9291](VELOCITY_X,0) = 0.000000; -NODES[9291](VELOCITY_Y,0) = 0.000000; -NODES[9291](VELOCITY_Z,0) = 0.000000; -NODES[9292](VELOCITY_X,0) = 0.000000; -NODES[9292](VELOCITY_Y,0) = 0.000000; -NODES[9292](VELOCITY_Z,0) = 0.000000; -NODES[9300](VELOCITY_X,0) = 0.000000; -NODES[9300](VELOCITY_Y,0) = 0.000000; -NODES[9300](VELOCITY_Z,0) = 0.000000; -NODES[9301](VELOCITY_X,0) = 0.000000; -NODES[9301](VELOCITY_Y,0) = 0.000000; -NODES[9301](VELOCITY_Z,0) = 0.000000; -NODES[9302](VELOCITY_X,0) = 0.000000; -NODES[9302](VELOCITY_Y,0) = 0.000000; -NODES[9302](VELOCITY_Z,0) = 0.000000; -NODES[9303](VELOCITY_X,0) = 0.000000; -NODES[9303](VELOCITY_Y,0) = 0.000000; -NODES[9303](VELOCITY_Z,0) = 0.000000; -NODES[9304](VELOCITY_X,0) = 0.000000; -NODES[9304](VELOCITY_Y,0) = 0.000000; -NODES[9304](VELOCITY_Z,0) = 0.000000; -NODES[9305](VELOCITY_X,0) = 0.000000; -NODES[9305](VELOCITY_Y,0) = 0.000000; -NODES[9305](VELOCITY_Z,0) = 0.000000; -NODES[9315](VELOCITY_X,0) = 0.000000; -NODES[9315](VELOCITY_Y,0) = 0.000000; -NODES[9315](VELOCITY_Z,0) = 0.000000; -NODES[9318](VELOCITY_X,0) = 0.000000; -NODES[9318](VELOCITY_Y,0) = 0.000000; -NODES[9318](VELOCITY_Z,0) = 0.000000; -NODES[9324](VELOCITY_X,0) = 0.000000; -NODES[9324](VELOCITY_Y,0) = 0.000000; -NODES[9324](VELOCITY_Z,0) = 0.000000; -NODES[9326](VELOCITY_X,0) = 0.000000; -NODES[9326](VELOCITY_Y,0) = 0.000000; -NODES[9326](VELOCITY_Z,0) = 0.000000; -NODES[9332](VELOCITY_X,0) = 0.000000; -NODES[9332](VELOCITY_Y,0) = 0.000000; -NODES[9332](VELOCITY_Z,0) = 0.000000; -NODES[9339](VELOCITY_X,0) = 0.000000; -NODES[9339](VELOCITY_Y,0) = 0.000000; -NODES[9339](VELOCITY_Z,0) = 0.000000; -NODES[9342](VELOCITY_X,0) = 0.000000; -NODES[9342](VELOCITY_Y,0) = 0.000000; -NODES[9342](VELOCITY_Z,0) = 0.000000; -NODES[9343](VELOCITY_X,0) = 0.000000; -NODES[9343](VELOCITY_Y,0) = 0.000000; -NODES[9343](VELOCITY_Z,0) = 0.000000; -NODES[9344](VELOCITY_X,0) = 0.000000; -NODES[9344](VELOCITY_Y,0) = 0.000000; -NODES[9344](VELOCITY_Z,0) = 0.000000; -NODES[9345](VELOCITY_X,0) = 0.000000; -NODES[9345](VELOCITY_Y,0) = 0.000000; -NODES[9345](VELOCITY_Z,0) = 0.000000; -NODES[9346](VELOCITY_X,0) = 0.000000; -NODES[9346](VELOCITY_Y,0) = 0.000000; -NODES[9346](VELOCITY_Z,0) = 0.000000; -NODES[9347](VELOCITY_X,0) = 0.000000; -NODES[9347](VELOCITY_Y,0) = 0.000000; -NODES[9347](VELOCITY_Z,0) = 0.000000; -NODES[9349](VELOCITY_X,0) = 0.000000; -NODES[9349](VELOCITY_Y,0) = 0.000000; -NODES[9349](VELOCITY_Z,0) = 0.000000; -NODES[9369](VELOCITY_X,0) = 0.000000; -NODES[9369](VELOCITY_Y,0) = 0.000000; -NODES[9369](VELOCITY_Z,0) = 0.000000; -NODES[9370](VELOCITY_X,0) = 0.000000; -NODES[9370](VELOCITY_Y,0) = 0.000000; -NODES[9370](VELOCITY_Z,0) = 0.000000; -NODES[9380](VELOCITY_X,0) = 0.000000; -NODES[9380](VELOCITY_Y,0) = 0.000000; -NODES[9380](VELOCITY_Z,0) = 0.000000; -NODES[9388](VELOCITY_X,0) = 0.000000; -NODES[9388](VELOCITY_Y,0) = 0.000000; -NODES[9388](VELOCITY_Z,0) = 0.000000; -NODES[9394](VELOCITY_X,0) = 0.000000; -NODES[9394](VELOCITY_Y,0) = 0.000000; -NODES[9394](VELOCITY_Z,0) = 0.000000; -NODES[9405](VELOCITY_X,0) = 0.000000; -NODES[9405](VELOCITY_Y,0) = 0.000000; -NODES[9405](VELOCITY_Z,0) = 0.000000; -NODES[9422](VELOCITY_X,0) = 0.000000; -NODES[9422](VELOCITY_Y,0) = 0.000000; -NODES[9422](VELOCITY_Z,0) = 0.000000; -NODES[9423](VELOCITY_X,0) = 0.000000; -NODES[9423](VELOCITY_Y,0) = 0.000000; -NODES[9423](VELOCITY_Z,0) = 0.000000; -NODES[9425](VELOCITY_X,0) = 0.000000; -NODES[9425](VELOCITY_Y,0) = 0.000000; -NODES[9425](VELOCITY_Z,0) = 0.000000; -NODES[9432](VELOCITY_X,0) = 0.000000; -NODES[9432](VELOCITY_Y,0) = 0.000000; -NODES[9432](VELOCITY_Z,0) = 0.000000; -NODES[9435](VELOCITY_X,0) = 0.000000; -NODES[9435](VELOCITY_Y,0) = 0.000000; -NODES[9435](VELOCITY_Z,0) = 0.000000; -NODES[9436](VELOCITY_X,0) = 0.000000; -NODES[9436](VELOCITY_Y,0) = 0.000000; -NODES[9436](VELOCITY_Z,0) = 0.000000; -NODES[9449](VELOCITY_X,0) = 0.000000; -NODES[9449](VELOCITY_Y,0) = 0.000000; -NODES[9449](VELOCITY_Z,0) = 0.000000; -NODES[9450](VELOCITY_X,0) = 0.000000; -NODES[9450](VELOCITY_Y,0) = 0.000000; -NODES[9450](VELOCITY_Z,0) = 0.000000; -NODES[9453](VELOCITY_X,0) = 0.000000; -NODES[9453](VELOCITY_Y,0) = 0.000000; -NODES[9453](VELOCITY_Z,0) = 0.000000; -NODES[9454](VELOCITY_X,0) = 0.000000; -NODES[9454](VELOCITY_Y,0) = 0.000000; -NODES[9454](VELOCITY_Z,0) = 0.000000; -NODES[9490](VELOCITY_X,0) = 0.000000; -NODES[9490](VELOCITY_Y,0) = 0.000000; -NODES[9490](VELOCITY_Z,0) = 0.000000; -NODES[9494](VELOCITY_X,0) = 0.000000; -NODES[9494](VELOCITY_Y,0) = 0.000000; -NODES[9494](VELOCITY_Z,0) = 0.000000; -NODES[9496](VELOCITY_X,0) = 0.000000; -NODES[9496](VELOCITY_Y,0) = 0.000000; -NODES[9496](VELOCITY_Z,0) = 0.000000; -NODES[9497](VELOCITY_X,0) = 0.000000; -NODES[9497](VELOCITY_Y,0) = 0.000000; -NODES[9497](VELOCITY_Z,0) = 0.000000; -NODES[9507](VELOCITY_X,0) = 0.000000; -NODES[9507](VELOCITY_Y,0) = 0.000000; -NODES[9507](VELOCITY_Z,0) = 0.000000; -NODES[9515](VELOCITY_X,0) = 0.000000; -NODES[9515](VELOCITY_Y,0) = 0.000000; -NODES[9515](VELOCITY_Z,0) = 0.000000; -NODES[9521](VELOCITY_X,0) = 0.000000; -NODES[9521](VELOCITY_Y,0) = 0.000000; -NODES[9521](VELOCITY_Z,0) = 0.000000; -NODES[9522](VELOCITY_X,0) = 0.000000; -NODES[9522](VELOCITY_Y,0) = 0.000000; -NODES[9522](VELOCITY_Z,0) = 0.000000; -NODES[9523](VELOCITY_X,0) = 0.000000; -NODES[9523](VELOCITY_Y,0) = 0.000000; -NODES[9523](VELOCITY_Z,0) = 0.000000; -NODES[9524](VELOCITY_X,0) = 0.000000; -NODES[9524](VELOCITY_Y,0) = 0.000000; -NODES[9524](VELOCITY_Z,0) = 0.000000; -NODES[9525](VELOCITY_X,0) = 0.000000; -NODES[9525](VELOCITY_Y,0) = 0.000000; -NODES[9525](VELOCITY_Z,0) = 0.000000; -NODES[9526](VELOCITY_X,0) = 0.000000; -NODES[9526](VELOCITY_Y,0) = 0.000000; -NODES[9526](VELOCITY_Z,0) = 0.000000; -NODES[9537](VELOCITY_X,0) = 0.000000; -NODES[9537](VELOCITY_Y,0) = 0.000000; -NODES[9537](VELOCITY_Z,0) = 0.000000; -NODES[9539](VELOCITY_X,0) = 0.000000; -NODES[9539](VELOCITY_Y,0) = 0.000000; -NODES[9539](VELOCITY_Z,0) = 0.000000; -NODES[9541](VELOCITY_X,0) = 0.000000; -NODES[9541](VELOCITY_Y,0) = 0.000000; -NODES[9541](VELOCITY_Z,0) = 0.000000; -NODES[9547](VELOCITY_X,0) = 0.000000; -NODES[9547](VELOCITY_Y,0) = 0.000000; -NODES[9547](VELOCITY_Z,0) = 0.000000; -NODES[9557](VELOCITY_X,0) = 0.000000; -NODES[9557](VELOCITY_Y,0) = 0.000000; -NODES[9557](VELOCITY_Z,0) = 0.000000; -NODES[9558](VELOCITY_X,0) = 0.000000; -NODES[9558](VELOCITY_Y,0) = 0.000000; -NODES[9558](VELOCITY_Z,0) = 0.000000; -NODES[9561](VELOCITY_X,0) = 0.000000; -NODES[9561](VELOCITY_Y,0) = 0.000000; -NODES[9561](VELOCITY_Z,0) = 0.000000; -NODES[9562](VELOCITY_X,0) = 0.000000; -NODES[9562](VELOCITY_Y,0) = 0.000000; -NODES[9562](VELOCITY_Z,0) = 0.000000; -NODES[9563](VELOCITY_X,0) = 0.000000; -NODES[9563](VELOCITY_Y,0) = 0.000000; -NODES[9563](VELOCITY_Z,0) = 0.000000; -NODES[9578](VELOCITY_X,0) = 0.000000; -NODES[9578](VELOCITY_Y,0) = 0.000000; -NODES[9578](VELOCITY_Z,0) = 0.000000; -NODES[9579](VELOCITY_X,0) = 0.000000; -NODES[9579](VELOCITY_Y,0) = 0.000000; -NODES[9579](VELOCITY_Z,0) = 0.000000; -NODES[9580](VELOCITY_X,0) = 0.000000; -NODES[9580](VELOCITY_Y,0) = 0.000000; -NODES[9580](VELOCITY_Z,0) = 0.000000; -NODES[9586](VELOCITY_X,0) = 0.000000; -NODES[9586](VELOCITY_Y,0) = 0.000000; -NODES[9586](VELOCITY_Z,0) = 0.000000; -NODES[9600](VELOCITY_X,0) = 0.000000; -NODES[9600](VELOCITY_Y,0) = 0.000000; -NODES[9600](VELOCITY_Z,0) = 0.000000; -NODES[9605](VELOCITY_X,0) = 0.000000; -NODES[9605](VELOCITY_Y,0) = 0.000000; -NODES[9605](VELOCITY_Z,0) = 0.000000; -NODES[9606](VELOCITY_X,0) = 0.000000; -NODES[9606](VELOCITY_Y,0) = 0.000000; -NODES[9606](VELOCITY_Z,0) = 0.000000; -NODES[9624](VELOCITY_X,0) = 0.000000; -NODES[9624](VELOCITY_Y,0) = 0.000000; -NODES[9624](VELOCITY_Z,0) = 0.000000; -NODES[9625](VELOCITY_X,0) = 0.000000; -NODES[9625](VELOCITY_Y,0) = 0.000000; -NODES[9625](VELOCITY_Z,0) = 0.000000; -NODES[9626](VELOCITY_X,0) = 0.000000; -NODES[9626](VELOCITY_Y,0) = 0.000000; -NODES[9626](VELOCITY_Z,0) = 0.000000; -NODES[9632](VELOCITY_X,0) = 0.000000; -NODES[9632](VELOCITY_Y,0) = 0.000000; -NODES[9632](VELOCITY_Z,0) = 0.000000; -NODES[9639](VELOCITY_X,0) = 0.000000; -NODES[9639](VELOCITY_Y,0) = 0.000000; -NODES[9639](VELOCITY_Z,0) = 0.000000; -NODES[9643](VELOCITY_X,0) = 0.000000; -NODES[9643](VELOCITY_Y,0) = 0.000000; -NODES[9643](VELOCITY_Z,0) = 0.000000; -NODES[9650](VELOCITY_X,0) = 0.000000; -NODES[9650](VELOCITY_Y,0) = 0.000000; -NODES[9650](VELOCITY_Z,0) = 0.000000; -NODES[9651](VELOCITY_X,0) = 0.000000; -NODES[9651](VELOCITY_Y,0) = 0.000000; -NODES[9651](VELOCITY_Z,0) = 0.000000; -NODES[9654](VELOCITY_X,0) = 0.000000; -NODES[9654](VELOCITY_Y,0) = 0.000000; -NODES[9654](VELOCITY_Z,0) = 0.000000; -NODES[9656](VELOCITY_X,0) = 0.000000; -NODES[9656](VELOCITY_Y,0) = 0.000000; -NODES[9656](VELOCITY_Z,0) = 0.000000; -NODES[9670](VELOCITY_X,0) = 0.000000; -NODES[9670](VELOCITY_Y,0) = 0.000000; -NODES[9670](VELOCITY_Z,0) = 0.000000; -NODES[9671](VELOCITY_X,0) = 0.000000; -NODES[9671](VELOCITY_Y,0) = 0.000000; -NODES[9671](VELOCITY_Z,0) = 0.000000; -NODES[9694](VELOCITY_X,0) = 0.000000; -NODES[9694](VELOCITY_Y,0) = 0.000000; -NODES[9694](VELOCITY_Z,0) = 0.000000; -NODES[9700](VELOCITY_X,0) = 0.000000; -NODES[9700](VELOCITY_Y,0) = 0.000000; -NODES[9700](VELOCITY_Z,0) = 0.000000; -NODES[9711](VELOCITY_X,0) = 0.000000; -NODES[9711](VELOCITY_Y,0) = 0.000000; -NODES[9711](VELOCITY_Z,0) = 0.000000; -NODES[9716](VELOCITY_X,0) = 0.000000; -NODES[9716](VELOCITY_Y,0) = 0.000000; -NODES[9716](VELOCITY_Z,0) = 0.000000; -NODES[9718](VELOCITY_X,0) = 0.000000; -NODES[9718](VELOCITY_Y,0) = 0.000000; -NODES[9718](VELOCITY_Z,0) = 0.000000; -NODES[9719](VELOCITY_X,0) = 0.000000; -NODES[9719](VELOCITY_Y,0) = 0.000000; -NODES[9719](VELOCITY_Z,0) = 0.000000; -NODES[9721](VELOCITY_X,0) = 0.000000; -NODES[9721](VELOCITY_Y,0) = 0.000000; -NODES[9721](VELOCITY_Z,0) = 0.000000; -NODES[9726](VELOCITY_X,0) = 0.000000; -NODES[9726](VELOCITY_Y,0) = 0.000000; -NODES[9726](VELOCITY_Z,0) = 0.000000; -NODES[9727](VELOCITY_X,0) = 0.000000; -NODES[9727](VELOCITY_Y,0) = 0.000000; -NODES[9727](VELOCITY_Z,0) = 0.000000; -NODES[9728](VELOCITY_X,0) = 0.000000; -NODES[9728](VELOCITY_Y,0) = 0.000000; -NODES[9728](VELOCITY_Z,0) = 0.000000; -NODES[9729](VELOCITY_X,0) = 0.000000; -NODES[9729](VELOCITY_Y,0) = 0.000000; -NODES[9729](VELOCITY_Z,0) = 0.000000; -NODES[9730](VELOCITY_X,0) = 0.000000; -NODES[9730](VELOCITY_Y,0) = 0.000000; -NODES[9730](VELOCITY_Z,0) = 0.000000; -NODES[9731](VELOCITY_X,0) = 0.000000; -NODES[9731](VELOCITY_Y,0) = 0.000000; -NODES[9731](VELOCITY_Z,0) = 0.000000; -NODES[9732](VELOCITY_X,0) = 0.000000; -NODES[9732](VELOCITY_Y,0) = 0.000000; -NODES[9732](VELOCITY_Z,0) = 0.000000; -NODES[9736](VELOCITY_X,0) = 0.000000; -NODES[9736](VELOCITY_Y,0) = 0.000000; -NODES[9736](VELOCITY_Z,0) = 0.000000; -NODES[9737](VELOCITY_X,0) = 0.000000; -NODES[9737](VELOCITY_Y,0) = 0.000000; -NODES[9737](VELOCITY_Z,0) = 0.000000; -NODES[9739](VELOCITY_X,0) = 0.000000; -NODES[9739](VELOCITY_Y,0) = 0.000000; -NODES[9739](VELOCITY_Z,0) = 0.000000; -NODES[9740](VELOCITY_X,0) = 0.000000; -NODES[9740](VELOCITY_Y,0) = 0.000000; -NODES[9740](VELOCITY_Z,0) = 0.000000; -NODES[9742](VELOCITY_X,0) = 0.000000; -NODES[9742](VELOCITY_Y,0) = 0.000000; -NODES[9742](VELOCITY_Z,0) = 0.000000; -NODES[9743](VELOCITY_X,0) = 0.000000; -NODES[9743](VELOCITY_Y,0) = 0.000000; -NODES[9743](VELOCITY_Z,0) = 0.000000; -NODES[9746](VELOCITY_X,0) = 0.000000; -NODES[9746](VELOCITY_Y,0) = 0.000000; -NODES[9746](VELOCITY_Z,0) = 0.000000; -NODES[9749](VELOCITY_X,0) = 0.000000; -NODES[9749](VELOCITY_Y,0) = 0.000000; -NODES[9749](VELOCITY_Z,0) = 0.000000; -NODES[9750](VELOCITY_X,0) = 0.000000; -NODES[9750](VELOCITY_Y,0) = 0.000000; -NODES[9750](VELOCITY_Z,0) = 0.000000; -NODES[9757](VELOCITY_X,0) = 0.000000; -NODES[9757](VELOCITY_Y,0) = 0.000000; -NODES[9757](VELOCITY_Z,0) = 0.000000; -NODES[9759](VELOCITY_X,0) = 0.000000; -NODES[9759](VELOCITY_Y,0) = 0.000000; -NODES[9759](VELOCITY_Z,0) = 0.000000; -NODES[9763](VELOCITY_X,0) = 0.000000; -NODES[9763](VELOCITY_Y,0) = 0.000000; -NODES[9763](VELOCITY_Z,0) = 0.000000; -NODES[9765](VELOCITY_X,0) = 0.000000; -NODES[9765](VELOCITY_Y,0) = 0.000000; -NODES[9765](VELOCITY_Z,0) = 0.000000; -NODES[9767](VELOCITY_X,0) = 0.000000; -NODES[9767](VELOCITY_Y,0) = 0.000000; -NODES[9767](VELOCITY_Z,0) = 0.000000; -NODES[9768](VELOCITY_X,0) = 0.000000; -NODES[9768](VELOCITY_Y,0) = 0.000000; -NODES[9768](VELOCITY_Z,0) = 0.000000; -NODES[9769](VELOCITY_X,0) = 0.000000; -NODES[9769](VELOCITY_Y,0) = 0.000000; -NODES[9769](VELOCITY_Z,0) = 0.000000; -NODES[9778](VELOCITY_X,0) = 0.000000; -NODES[9778](VELOCITY_Y,0) = 0.000000; -NODES[9778](VELOCITY_Z,0) = 0.000000; -NODES[9783](VELOCITY_X,0) = 0.000000; -NODES[9783](VELOCITY_Y,0) = 0.000000; -NODES[9783](VELOCITY_Z,0) = 0.000000; -NODES[9784](VELOCITY_X,0) = 0.000000; -NODES[9784](VELOCITY_Y,0) = 0.000000; -NODES[9784](VELOCITY_Z,0) = 0.000000; -NODES[9789](VELOCITY_X,0) = 0.000000; -NODES[9789](VELOCITY_Y,0) = 0.000000; -NODES[9789](VELOCITY_Z,0) = 0.000000; -NODES[9805](VELOCITY_X,0) = 0.000000; -NODES[9805](VELOCITY_Y,0) = 0.000000; -NODES[9805](VELOCITY_Z,0) = 0.000000; -NODES[9810](VELOCITY_X,0) = 0.000000; -NODES[9810](VELOCITY_Y,0) = 0.000000; -NODES[9810](VELOCITY_Z,0) = 0.000000; -NODES[9814](VELOCITY_X,0) = 0.000000; -NODES[9814](VELOCITY_Y,0) = 0.000000; -NODES[9814](VELOCITY_Z,0) = 0.000000; -NODES[9829](VELOCITY_X,0) = 0.000000; -NODES[9829](VELOCITY_Y,0) = 0.000000; -NODES[9829](VELOCITY_Z,0) = 0.000000; -NODES[9830](VELOCITY_X,0) = 0.000000; -NODES[9830](VELOCITY_Y,0) = 0.000000; -NODES[9830](VELOCITY_Z,0) = 0.000000; -NODES[9831](VELOCITY_X,0) = 0.000000; -NODES[9831](VELOCITY_Y,0) = 0.000000; -NODES[9831](VELOCITY_Z,0) = 0.000000; -NODES[9841](VELOCITY_X,0) = 0.000000; -NODES[9841](VELOCITY_Y,0) = 0.000000; -NODES[9841](VELOCITY_Z,0) = 0.000000; -NODES[9842](VELOCITY_X,0) = 0.000000; -NODES[9842](VELOCITY_Y,0) = 0.000000; -NODES[9842](VELOCITY_Z,0) = 0.000000; -NODES[9843](VELOCITY_X,0) = 0.000000; -NODES[9843](VELOCITY_Y,0) = 0.000000; -NODES[9843](VELOCITY_Z,0) = 0.000000; -NODES[9844](VELOCITY_X,0) = 0.000000; -NODES[9844](VELOCITY_Y,0) = 0.000000; -NODES[9844](VELOCITY_Z,0) = 0.000000; -NODES[9861](VELOCITY_X,0) = 0.000000; -NODES[9861](VELOCITY_Y,0) = 0.000000; -NODES[9861](VELOCITY_Z,0) = 0.000000; -NODES[9864](VELOCITY_X,0) = 0.000000; -NODES[9864](VELOCITY_Y,0) = 0.000000; -NODES[9864](VELOCITY_Z,0) = 0.000000; -NODES[9867](VELOCITY_X,0) = 0.000000; -NODES[9867](VELOCITY_Y,0) = 0.000000; -NODES[9867](VELOCITY_Z,0) = 0.000000; -NODES[9868](VELOCITY_X,0) = 0.000000; -NODES[9868](VELOCITY_Y,0) = 0.000000; -NODES[9868](VELOCITY_Z,0) = 0.000000; -NODES[9873](VELOCITY_X,0) = 0.000000; -NODES[9873](VELOCITY_Y,0) = 0.000000; -NODES[9873](VELOCITY_Z,0) = 0.000000; -NODES[9874](VELOCITY_X,0) = 0.000000; -NODES[9874](VELOCITY_Y,0) = 0.000000; -NODES[9874](VELOCITY_Z,0) = 0.000000; -NODES[9878](VELOCITY_X,0) = 0.000000; -NODES[9878](VELOCITY_Y,0) = 0.000000; -NODES[9878](VELOCITY_Z,0) = 0.000000; -NODES[9879](VELOCITY_X,0) = 0.000000; -NODES[9879](VELOCITY_Y,0) = 0.000000; -NODES[9879](VELOCITY_Z,0) = 0.000000; -NODES[9880](VELOCITY_X,0) = 0.000000; -NODES[9880](VELOCITY_Y,0) = 0.000000; -NODES[9880](VELOCITY_Z,0) = 0.000000; -NODES[9881](VELOCITY_X,0) = 0.000000; -NODES[9881](VELOCITY_Y,0) = 0.000000; -NODES[9881](VELOCITY_Z,0) = 0.000000; -NODES[9891](VELOCITY_X,0) = 0.000000; -NODES[9891](VELOCITY_Y,0) = 0.000000; -NODES[9891](VELOCITY_Z,0) = 0.000000; -NODES[9897](VELOCITY_X,0) = 0.000000; -NODES[9897](VELOCITY_Y,0) = 0.000000; -NODES[9897](VELOCITY_Z,0) = 0.000000; -NODES[9900](VELOCITY_X,0) = 0.000000; -NODES[9900](VELOCITY_Y,0) = 0.000000; -NODES[9900](VELOCITY_Z,0) = 0.000000; -NODES[9915](VELOCITY_X,0) = 0.000000; -NODES[9915](VELOCITY_Y,0) = 0.000000; -NODES[9915](VELOCITY_Z,0) = 0.000000; -NODES[9916](VELOCITY_X,0) = 0.000000; -NODES[9916](VELOCITY_Y,0) = 0.000000; -NODES[9916](VELOCITY_Z,0) = 0.000000; -NODES[9921](VELOCITY_X,0) = 0.000000; -NODES[9921](VELOCITY_Y,0) = 0.000000; -NODES[9921](VELOCITY_Z,0) = 0.000000; -NODES[9926](VELOCITY_X,0) = 0.000000; -NODES[9926](VELOCITY_Y,0) = 0.000000; -NODES[9926](VELOCITY_Z,0) = 0.000000; -NODES[9930](VELOCITY_X,0) = 0.000000; -NODES[9930](VELOCITY_Y,0) = 0.000000; -NODES[9930](VELOCITY_Z,0) = 0.000000; -NODES[9937](VELOCITY_X,0) = 0.000000; -NODES[9937](VELOCITY_Y,0) = 0.000000; -NODES[9937](VELOCITY_Z,0) = 0.000000; -NODES[9938](VELOCITY_X,0) = 0.000000; -NODES[9938](VELOCITY_Y,0) = 0.000000; -NODES[9938](VELOCITY_Z,0) = 0.000000; -NODES[9939](VELOCITY_X,0) = 0.000000; -NODES[9939](VELOCITY_Y,0) = 0.000000; -NODES[9939](VELOCITY_Z,0) = 0.000000; -NODES[9946](VELOCITY_X,0) = 0.000000; -NODES[9946](VELOCITY_Y,0) = 0.000000; -NODES[9946](VELOCITY_Z,0) = 0.000000; -NODES[9947](VELOCITY_X,0) = 0.000000; -NODES[9947](VELOCITY_Y,0) = 0.000000; -NODES[9947](VELOCITY_Z,0) = 0.000000; -NODES[9948](VELOCITY_X,0) = 0.000000; -NODES[9948](VELOCITY_Y,0) = 0.000000; -NODES[9948](VELOCITY_Z,0) = 0.000000; -NODES[9964](VELOCITY_X,0) = 0.000000; -NODES[9964](VELOCITY_Y,0) = 0.000000; -NODES[9964](VELOCITY_Z,0) = 0.000000; -NODES[9975](VELOCITY_X,0) = 0.000000; -NODES[9975](VELOCITY_Y,0) = 0.000000; -NODES[9975](VELOCITY_Z,0) = 0.000000; -NODES[9976](VELOCITY_X,0) = 0.000000; -NODES[9976](VELOCITY_Y,0) = 0.000000; -NODES[9976](VELOCITY_Z,0) = 0.000000; -NODES[9978](VELOCITY_X,0) = 0.000000; -NODES[9978](VELOCITY_Y,0) = 0.000000; -NODES[9978](VELOCITY_Z,0) = 0.000000; -NODES[9979](VELOCITY_X,0) = 0.000000; -NODES[9979](VELOCITY_Y,0) = 0.000000; -NODES[9979](VELOCITY_Z,0) = 0.000000; -NODES[9981](VELOCITY_X,0) = 0.000000; -NODES[9981](VELOCITY_Y,0) = 0.000000; -NODES[9981](VELOCITY_Z,0) = 0.000000; -NODES[9987](VELOCITY_X,0) = 0.000000; -NODES[9987](VELOCITY_Y,0) = 0.000000; -NODES[9987](VELOCITY_Z,0) = 0.000000; -NODES[9988](VELOCITY_X,0) = 0.000000; -NODES[9988](VELOCITY_Y,0) = 0.000000; -NODES[9988](VELOCITY_Z,0) = 0.000000; -NODES[9989](VELOCITY_X,0) = 0.000000; -NODES[9989](VELOCITY_Y,0) = 0.000000; -NODES[9989](VELOCITY_Z,0) = 0.000000; -NODES[10011](VELOCITY_X,0) = 0.000000; -NODES[10011](VELOCITY_Y,0) = 0.000000; -NODES[10011](VELOCITY_Z,0) = 0.000000; -NODES[10024](VELOCITY_X,0) = 0.000000; -NODES[10024](VELOCITY_Y,0) = 0.000000; -NODES[10024](VELOCITY_Z,0) = 0.000000; -NODES[10025](VELOCITY_X,0) = 0.000000; -NODES[10025](VELOCITY_Y,0) = 0.000000; -NODES[10025](VELOCITY_Z,0) = 0.000000; -NODES[10032](VELOCITY_X,0) = 0.000000; -NODES[10032](VELOCITY_Y,0) = 0.000000; -NODES[10032](VELOCITY_Z,0) = 0.000000; -NODES[10039](VELOCITY_X,0) = 0.000000; -NODES[10039](VELOCITY_Y,0) = 0.000000; -NODES[10039](VELOCITY_Z,0) = 0.000000; -NODES[10045](VELOCITY_X,0) = 0.000000; -NODES[10045](VELOCITY_Y,0) = 0.000000; -NODES[10045](VELOCITY_Z,0) = 0.000000; -NODES[10046](VELOCITY_X,0) = 0.000000; -NODES[10046](VELOCITY_Y,0) = 0.000000; -NODES[10046](VELOCITY_Z,0) = 0.000000; -NODES[10047](VELOCITY_X,0) = 0.000000; -NODES[10047](VELOCITY_Y,0) = 0.000000; -NODES[10047](VELOCITY_Z,0) = 0.000000; -NODES[10052](VELOCITY_X,0) = 0.000000; -NODES[10052](VELOCITY_Y,0) = 0.000000; -NODES[10052](VELOCITY_Z,0) = 0.000000; -NODES[10053](VELOCITY_X,0) = 0.000000; -NODES[10053](VELOCITY_Y,0) = 0.000000; -NODES[10053](VELOCITY_Z,0) = 0.000000; -NODES[10060](VELOCITY_X,0) = 0.000000; -NODES[10060](VELOCITY_Y,0) = 0.000000; -NODES[10060](VELOCITY_Z,0) = 0.000000; -NODES[10062](VELOCITY_X,0) = 0.000000; -NODES[10062](VELOCITY_Y,0) = 0.000000; -NODES[10062](VELOCITY_Z,0) = 0.000000; -NODES[10063](VELOCITY_X,0) = 0.000000; -NODES[10063](VELOCITY_Y,0) = 0.000000; -NODES[10063](VELOCITY_Z,0) = 0.000000; -NODES[10064](VELOCITY_X,0) = 0.000000; -NODES[10064](VELOCITY_Y,0) = 0.000000; -NODES[10064](VELOCITY_Z,0) = 0.000000; -NODES[10067](VELOCITY_X,0) = 0.000000; -NODES[10067](VELOCITY_Y,0) = 0.000000; -NODES[10067](VELOCITY_Z,0) = 0.000000; -NODES[10075](VELOCITY_X,0) = 0.000000; -NODES[10075](VELOCITY_Y,0) = 0.000000; -NODES[10075](VELOCITY_Z,0) = 0.000000; -NODES[10081](VELOCITY_X,0) = 0.000000; -NODES[10081](VELOCITY_Y,0) = 0.000000; -NODES[10081](VELOCITY_Z,0) = 0.000000; -NODES[10083](VELOCITY_X,0) = 0.000000; -NODES[10083](VELOCITY_Y,0) = 0.000000; -NODES[10083](VELOCITY_Z,0) = 0.000000; -NODES[10095](VELOCITY_X,0) = 0.000000; -NODES[10095](VELOCITY_Y,0) = 0.000000; -NODES[10095](VELOCITY_Z,0) = 0.000000; -NODES[10101](VELOCITY_X,0) = 0.000000; -NODES[10101](VELOCITY_Y,0) = 0.000000; -NODES[10101](VELOCITY_Z,0) = 0.000000; -NODES[10111](VELOCITY_X,0) = 0.000000; -NODES[10111](VELOCITY_Y,0) = 0.000000; -NODES[10111](VELOCITY_Z,0) = 0.000000; -NODES[10124](VELOCITY_X,0) = 0.000000; -NODES[10124](VELOCITY_Y,0) = 0.000000; -NODES[10124](VELOCITY_Z,0) = 0.000000; -NODES[10125](VELOCITY_X,0) = 0.000000; -NODES[10125](VELOCITY_Y,0) = 0.000000; -NODES[10125](VELOCITY_Z,0) = 0.000000; -NODES[10129](VELOCITY_X,0) = 0.000000; -NODES[10129](VELOCITY_Y,0) = 0.000000; -NODES[10129](VELOCITY_Z,0) = 0.000000; -NODES[10136](VELOCITY_X,0) = 0.000000; -NODES[10136](VELOCITY_Y,0) = 0.000000; -NODES[10136](VELOCITY_Z,0) = 0.000000; -NODES[10139](VELOCITY_X,0) = 0.000000; -NODES[10139](VELOCITY_Y,0) = 0.000000; -NODES[10139](VELOCITY_Z,0) = 0.000000; -NODES[10140](VELOCITY_X,0) = 0.000000; -NODES[10140](VELOCITY_Y,0) = 0.000000; -NODES[10140](VELOCITY_Z,0) = 0.000000; -NODES[10141](VELOCITY_X,0) = 0.000000; -NODES[10141](VELOCITY_Y,0) = 0.000000; -NODES[10141](VELOCITY_Z,0) = 0.000000; -NODES[10150](VELOCITY_X,0) = 0.000000; -NODES[10150](VELOCITY_Y,0) = 0.000000; -NODES[10150](VELOCITY_Z,0) = 0.000000; -NODES[10151](VELOCITY_X,0) = 0.000000; -NODES[10151](VELOCITY_Y,0) = 0.000000; -NODES[10151](VELOCITY_Z,0) = 0.000000; -NODES[10161](VELOCITY_X,0) = 0.000000; -NODES[10161](VELOCITY_Y,0) = 0.000000; -NODES[10161](VELOCITY_Z,0) = 0.000000; -NODES[10162](VELOCITY_X,0) = 0.000000; -NODES[10162](VELOCITY_Y,0) = 0.000000; -NODES[10162](VELOCITY_Z,0) = 0.000000; -NODES[10163](VELOCITY_X,0) = 0.000000; -NODES[10163](VELOCITY_Y,0) = 0.000000; -NODES[10163](VELOCITY_Z,0) = 0.000000; -NODES[10164](VELOCITY_X,0) = 0.000000; -NODES[10164](VELOCITY_Y,0) = 0.000000; -NODES[10164](VELOCITY_Z,0) = 0.000000; -NODES[10165](VELOCITY_X,0) = 0.000000; -NODES[10165](VELOCITY_Y,0) = 0.000000; -NODES[10165](VELOCITY_Z,0) = 0.000000; -NODES[10166](VELOCITY_X,0) = 0.000000; -NODES[10166](VELOCITY_Y,0) = 0.000000; -NODES[10166](VELOCITY_Z,0) = 0.000000; -NODES[10172](VELOCITY_X,0) = 0.000000; -NODES[10172](VELOCITY_Y,0) = 0.000000; -NODES[10172](VELOCITY_Z,0) = 0.000000; -NODES[10175](VELOCITY_X,0) = 0.000000; -NODES[10175](VELOCITY_Y,0) = 0.000000; -NODES[10175](VELOCITY_Z,0) = 0.000000; -NODES[10176](VELOCITY_X,0) = 0.000000; -NODES[10176](VELOCITY_Y,0) = 0.000000; -NODES[10176](VELOCITY_Z,0) = 0.000000; -NODES[10177](VELOCITY_X,0) = 0.000000; -NODES[10177](VELOCITY_Y,0) = 0.000000; -NODES[10177](VELOCITY_Z,0) = 0.000000; -NODES[10183](VELOCITY_X,0) = 0.000000; -NODES[10183](VELOCITY_Y,0) = 0.000000; -NODES[10183](VELOCITY_Z,0) = 0.000000; -NODES[10189](VELOCITY_X,0) = 0.000000; -NODES[10189](VELOCITY_Y,0) = 0.000000; -NODES[10189](VELOCITY_Z,0) = 0.000000; -NODES[10196](VELOCITY_X,0) = 0.000000; -NODES[10196](VELOCITY_Y,0) = 0.000000; -NODES[10196](VELOCITY_Z,0) = 0.000000; -NODES[10197](VELOCITY_X,0) = 0.000000; -NODES[10197](VELOCITY_Y,0) = 0.000000; -NODES[10197](VELOCITY_Z,0) = 0.000000; -NODES[10198](VELOCITY_X,0) = 0.000000; -NODES[10198](VELOCITY_Y,0) = 0.000000; -NODES[10198](VELOCITY_Z,0) = 0.000000; -NODES[10201](VELOCITY_X,0) = 0.000000; -NODES[10201](VELOCITY_Y,0) = 0.000000; -NODES[10201](VELOCITY_Z,0) = 0.000000; -NODES[10203](VELOCITY_X,0) = 0.000000; -NODES[10203](VELOCITY_Y,0) = 0.000000; -NODES[10203](VELOCITY_Z,0) = 0.000000; -NODES[10204](VELOCITY_X,0) = 0.000000; -NODES[10204](VELOCITY_Y,0) = 0.000000; -NODES[10204](VELOCITY_Z,0) = 0.000000; -NODES[10223](VELOCITY_X,0) = 0.000000; -NODES[10223](VELOCITY_Y,0) = 0.000000; -NODES[10223](VELOCITY_Z,0) = 0.000000; -NODES[10226](VELOCITY_X,0) = 0.000000; -NODES[10226](VELOCITY_Y,0) = 0.000000; -NODES[10226](VELOCITY_Z,0) = 0.000000; -NODES[10227](VELOCITY_X,0) = 0.000000; -NODES[10227](VELOCITY_Y,0) = 0.000000; -NODES[10227](VELOCITY_Z,0) = 0.000000; -NODES[10237](VELOCITY_X,0) = 0.000000; -NODES[10237](VELOCITY_Y,0) = 0.000000; -NODES[10237](VELOCITY_Z,0) = 0.000000; -NODES[10246](VELOCITY_X,0) = 0.000000; -NODES[10246](VELOCITY_Y,0) = 0.000000; -NODES[10246](VELOCITY_Z,0) = 0.000000; -NODES[10247](VELOCITY_X,0) = 0.000000; -NODES[10247](VELOCITY_Y,0) = 0.000000; -NODES[10247](VELOCITY_Z,0) = 0.000000; -NODES[10251](VELOCITY_X,0) = 0.000000; -NODES[10251](VELOCITY_Y,0) = 0.000000; -NODES[10251](VELOCITY_Z,0) = 0.000000; -NODES[10253](VELOCITY_X,0) = 0.000000; -NODES[10253](VELOCITY_Y,0) = 0.000000; -NODES[10253](VELOCITY_Z,0) = 0.000000; -NODES[10259](VELOCITY_X,0) = 0.000000; -NODES[10259](VELOCITY_Y,0) = 0.000000; -NODES[10259](VELOCITY_Z,0) = 0.000000; -NODES[10279](VELOCITY_X,0) = 0.000000; -NODES[10279](VELOCITY_Y,0) = 0.000000; -NODES[10279](VELOCITY_Z,0) = 0.000000; -NODES[10280](VELOCITY_X,0) = 0.000000; -NODES[10280](VELOCITY_Y,0) = 0.000000; -NODES[10280](VELOCITY_Z,0) = 0.000000; -NODES[10285](VELOCITY_X,0) = 0.000000; -NODES[10285](VELOCITY_Y,0) = 0.000000; -NODES[10285](VELOCITY_Z,0) = 0.000000; -NODES[10286](VELOCITY_X,0) = 0.000000; -NODES[10286](VELOCITY_Y,0) = 0.000000; -NODES[10286](VELOCITY_Z,0) = 0.000000; -NODES[10300](VELOCITY_X,0) = 0.000000; -NODES[10300](VELOCITY_Y,0) = 0.000000; -NODES[10300](VELOCITY_Z,0) = 0.000000; -NODES[10301](VELOCITY_X,0) = 0.000000; -NODES[10301](VELOCITY_Y,0) = 0.000000; -NODES[10301](VELOCITY_Z,0) = 0.000000; -NODES[10311](VELOCITY_X,0) = 0.000000; -NODES[10311](VELOCITY_Y,0) = 0.000000; -NODES[10311](VELOCITY_Z,0) = 0.000000; -NODES[10312](VELOCITY_X,0) = 0.000000; -NODES[10312](VELOCITY_Y,0) = 0.000000; -NODES[10312](VELOCITY_Z,0) = 0.000000; -NODES[10315](VELOCITY_X,0) = 0.000000; -NODES[10315](VELOCITY_Y,0) = 0.000000; -NODES[10315](VELOCITY_Z,0) = 0.000000; -NODES[10328](VELOCITY_X,0) = 0.000000; -NODES[10328](VELOCITY_Y,0) = 0.000000; -NODES[10328](VELOCITY_Z,0) = 0.000000; -NODES[10331](VELOCITY_X,0) = 0.000000; -NODES[10331](VELOCITY_Y,0) = 0.000000; -NODES[10331](VELOCITY_Z,0) = 0.000000; -NODES[10332](VELOCITY_X,0) = 0.000000; -NODES[10332](VELOCITY_Y,0) = 0.000000; -NODES[10332](VELOCITY_Z,0) = 0.000000; -NODES[10334](VELOCITY_X,0) = 0.000000; -NODES[10334](VELOCITY_Y,0) = 0.000000; -NODES[10334](VELOCITY_Z,0) = 0.000000; -NODES[10341](VELOCITY_X,0) = 0.000000; -NODES[10341](VELOCITY_Y,0) = 0.000000; -NODES[10341](VELOCITY_Z,0) = 0.000000; -NODES[10342](VELOCITY_X,0) = 0.000000; -NODES[10342](VELOCITY_Y,0) = 0.000000; -NODES[10342](VELOCITY_Z,0) = 0.000000; -NODES[10348](VELOCITY_X,0) = 0.000000; -NODES[10348](VELOCITY_Y,0) = 0.000000; -NODES[10348](VELOCITY_Z,0) = 0.000000; -NODES[10353](VELOCITY_X,0) = 0.000000; -NODES[10353](VELOCITY_Y,0) = 0.000000; -NODES[10353](VELOCITY_Z,0) = 0.000000; -NODES[10355](VELOCITY_X,0) = 0.000000; -NODES[10355](VELOCITY_Y,0) = 0.000000; -NODES[10355](VELOCITY_Z,0) = 0.000000; -NODES[10375](VELOCITY_X,0) = 0.000000; -NODES[10375](VELOCITY_Y,0) = 0.000000; -NODES[10375](VELOCITY_Z,0) = 0.000000; -NODES[10379](VELOCITY_X,0) = 0.000000; -NODES[10379](VELOCITY_Y,0) = 0.000000; -NODES[10379](VELOCITY_Z,0) = 0.000000; -NODES[10380](VELOCITY_X,0) = 0.000000; -NODES[10380](VELOCITY_Y,0) = 0.000000; -NODES[10380](VELOCITY_Z,0) = 0.000000; -NODES[10385](VELOCITY_X,0) = 0.000000; -NODES[10385](VELOCITY_Y,0) = 0.000000; -NODES[10385](VELOCITY_Z,0) = 0.000000; -NODES[10395](VELOCITY_X,0) = 0.000000; -NODES[10395](VELOCITY_Y,0) = 0.000000; -NODES[10395](VELOCITY_Z,0) = 0.000000; -NODES[10411](VELOCITY_X,0) = 0.000000; -NODES[10411](VELOCITY_Y,0) = 0.000000; -NODES[10411](VELOCITY_Z,0) = 0.000000; -NODES[10412](VELOCITY_X,0) = 0.000000; -NODES[10412](VELOCITY_Y,0) = 0.000000; -NODES[10412](VELOCITY_Z,0) = 0.000000; -NODES[10415](VELOCITY_X,0) = 0.000000; -NODES[10415](VELOCITY_Y,0) = 0.000000; -NODES[10415](VELOCITY_Z,0) = 0.000000; -NODES[10416](VELOCITY_X,0) = 0.000000; -NODES[10416](VELOCITY_Y,0) = 0.000000; -NODES[10416](VELOCITY_Z,0) = 0.000000; -NODES[10417](VELOCITY_X,0) = 0.000000; -NODES[10417](VELOCITY_Y,0) = 0.000000; -NODES[10417](VELOCITY_Z,0) = 0.000000; -NODES[10418](VELOCITY_X,0) = 0.000000; -NODES[10418](VELOCITY_Y,0) = 0.000000; -NODES[10418](VELOCITY_Z,0) = 0.000000; -NODES[10423](VELOCITY_X,0) = 0.000000; -NODES[10423](VELOCITY_Y,0) = 0.000000; -NODES[10423](VELOCITY_Z,0) = 0.000000; -NODES[10444](VELOCITY_X,0) = 0.000000; -NODES[10444](VELOCITY_Y,0) = 0.000000; -NODES[10444](VELOCITY_Z,0) = 0.000000; -NODES[10445](VELOCITY_X,0) = 0.000000; -NODES[10445](VELOCITY_Y,0) = 0.000000; -NODES[10445](VELOCITY_Z,0) = 0.000000; -NODES[10460](VELOCITY_X,0) = 0.000000; -NODES[10460](VELOCITY_Y,0) = 0.000000; -NODES[10460](VELOCITY_Z,0) = 0.000000; -NODES[10481](VELOCITY_X,0) = 0.000000; -NODES[10481](VELOCITY_Y,0) = 0.000000; -NODES[10481](VELOCITY_Z,0) = 0.000000; -NODES[10485](VELOCITY_X,0) = 0.000000; -NODES[10485](VELOCITY_Y,0) = 0.000000; -NODES[10485](VELOCITY_Z,0) = 0.000000; -NODES[10489](VELOCITY_X,0) = 0.000000; -NODES[10489](VELOCITY_Y,0) = 0.000000; -NODES[10489](VELOCITY_Z,0) = 0.000000; -NODES[10490](VELOCITY_X,0) = 0.000000; -NODES[10490](VELOCITY_Y,0) = 0.000000; -NODES[10490](VELOCITY_Z,0) = 0.000000; -NODES[10491](VELOCITY_X,0) = 0.000000; -NODES[10491](VELOCITY_Y,0) = 0.000000; -NODES[10491](VELOCITY_Z,0) = 0.000000; -NODES[10499](VELOCITY_X,0) = 0.000000; -NODES[10499](VELOCITY_Y,0) = 0.000000; -NODES[10499](VELOCITY_Z,0) = 0.000000; -NODES[10505](VELOCITY_X,0) = 0.000000; -NODES[10505](VELOCITY_Y,0) = 0.000000; -NODES[10505](VELOCITY_Z,0) = 0.000000; -NODES[10507](VELOCITY_X,0) = 0.000000; -NODES[10507](VELOCITY_Y,0) = 0.000000; -NODES[10507](VELOCITY_Z,0) = 0.000000; -NODES[10508](VELOCITY_X,0) = 0.000000; -NODES[10508](VELOCITY_Y,0) = 0.000000; -NODES[10508](VELOCITY_Z,0) = 0.000000; -NODES[10510](VELOCITY_X,0) = 0.000000; -NODES[10510](VELOCITY_Y,0) = 0.000000; -NODES[10510](VELOCITY_Z,0) = 0.000000; -NODES[10513](VELOCITY_X,0) = 0.000000; -NODES[10513](VELOCITY_Y,0) = 0.000000; -NODES[10513](VELOCITY_Z,0) = 0.000000; -NODES[10517](VELOCITY_X,0) = 0.000000; -NODES[10517](VELOCITY_Y,0) = 0.000000; -NODES[10517](VELOCITY_Z,0) = 0.000000; -NODES[10518](VELOCITY_X,0) = 0.000000; -NODES[10518](VELOCITY_Y,0) = 0.000000; -NODES[10518](VELOCITY_Z,0) = 0.000000; -NODES[10519](VELOCITY_X,0) = 0.000000; -NODES[10519](VELOCITY_Y,0) = 0.000000; -NODES[10519](VELOCITY_Z,0) = 0.000000; -NODES[10521](VELOCITY_X,0) = 0.000000; -NODES[10521](VELOCITY_Y,0) = 0.000000; -NODES[10521](VELOCITY_Z,0) = 0.000000; -NODES[10522](VELOCITY_X,0) = 0.000000; -NODES[10522](VELOCITY_Y,0) = 0.000000; -NODES[10522](VELOCITY_Z,0) = 0.000000; -NODES[10523](VELOCITY_X,0) = 0.000000; -NODES[10523](VELOCITY_Y,0) = 0.000000; -NODES[10523](VELOCITY_Z,0) = 0.000000; -NODES[10532](VELOCITY_X,0) = 0.000000; -NODES[10532](VELOCITY_Y,0) = 0.000000; -NODES[10532](VELOCITY_Z,0) = 0.000000; -NODES[10547](VELOCITY_X,0) = 0.000000; -NODES[10547](VELOCITY_Y,0) = 0.000000; -NODES[10547](VELOCITY_Z,0) = 0.000000; -NODES[10554](VELOCITY_X,0) = 0.000000; -NODES[10554](VELOCITY_Y,0) = 0.000000; -NODES[10554](VELOCITY_Z,0) = 0.000000; -NODES[10565](VELOCITY_X,0) = 0.000000; -NODES[10565](VELOCITY_Y,0) = 0.000000; -NODES[10565](VELOCITY_Z,0) = 0.000000; -NODES[10574](VELOCITY_X,0) = 0.000000; -NODES[10574](VELOCITY_Y,0) = 0.000000; -NODES[10574](VELOCITY_Z,0) = 0.000000; -NODES[10578](VELOCITY_X,0) = 0.000000; -NODES[10578](VELOCITY_Y,0) = 0.000000; -NODES[10578](VELOCITY_Z,0) = 0.000000; -NODES[10583](VELOCITY_X,0) = 0.000000; -NODES[10583](VELOCITY_Y,0) = 0.000000; -NODES[10583](VELOCITY_Z,0) = 0.000000; -NODES[10584](VELOCITY_X,0) = 0.000000; -NODES[10584](VELOCITY_Y,0) = 0.000000; -NODES[10584](VELOCITY_Z,0) = 0.000000; -NODES[10585](VELOCITY_X,0) = 0.000000; -NODES[10585](VELOCITY_Y,0) = 0.000000; -NODES[10585](VELOCITY_Z,0) = 0.000000; -NODES[10588](VELOCITY_X,0) = 0.000000; -NODES[10588](VELOCITY_Y,0) = 0.000000; -NODES[10588](VELOCITY_Z,0) = 0.000000; -NODES[10589](VELOCITY_X,0) = 0.000000; -NODES[10589](VELOCITY_Y,0) = 0.000000; -NODES[10589](VELOCITY_Z,0) = 0.000000; -NODES[10598](VELOCITY_X,0) = 0.000000; -NODES[10598](VELOCITY_Y,0) = 0.000000; -NODES[10598](VELOCITY_Z,0) = 0.000000; -NODES[10607](VELOCITY_X,0) = 0.000000; -NODES[10607](VELOCITY_Y,0) = 0.000000; -NODES[10607](VELOCITY_Z,0) = 0.000000; -NODES[10608](VELOCITY_X,0) = 0.000000; -NODES[10608](VELOCITY_Y,0) = 0.000000; -NODES[10608](VELOCITY_Z,0) = 0.000000; -NODES[10609](VELOCITY_X,0) = 0.000000; -NODES[10609](VELOCITY_Y,0) = 0.000000; -NODES[10609](VELOCITY_Z,0) = 0.000000; -NODES[10610](VELOCITY_X,0) = 0.000000; -NODES[10610](VELOCITY_Y,0) = 0.000000; -NODES[10610](VELOCITY_Z,0) = 0.000000; -NODES[10611](VELOCITY_X,0) = 0.000000; -NODES[10611](VELOCITY_Y,0) = 0.000000; -NODES[10611](VELOCITY_Z,0) = 0.000000; -NODES[10616](VELOCITY_X,0) = 0.000000; -NODES[10616](VELOCITY_Y,0) = 0.000000; -NODES[10616](VELOCITY_Z,0) = 0.000000; -NODES[10617](VELOCITY_X,0) = 0.000000; -NODES[10617](VELOCITY_Y,0) = 0.000000; -NODES[10617](VELOCITY_Z,0) = 0.000000; -NODES[10620](VELOCITY_X,0) = 0.000000; -NODES[10620](VELOCITY_Y,0) = 0.000000; -NODES[10620](VELOCITY_Z,0) = 0.000000; -NODES[10643](VELOCITY_X,0) = 0.000000; -NODES[10643](VELOCITY_Y,0) = 0.000000; -NODES[10643](VELOCITY_Z,0) = 0.000000; -NODES[10644](VELOCITY_X,0) = 0.000000; -NODES[10644](VELOCITY_Y,0) = 0.000000; -NODES[10644](VELOCITY_Z,0) = 0.000000; -NODES[10645](VELOCITY_X,0) = 0.000000; -NODES[10645](VELOCITY_Y,0) = 0.000000; -NODES[10645](VELOCITY_Z,0) = 0.000000; -NODES[10646](VELOCITY_X,0) = 0.000000; -NODES[10646](VELOCITY_Y,0) = 0.000000; -NODES[10646](VELOCITY_Z,0) = 0.000000; -NODES[10647](VELOCITY_X,0) = 0.000000; -NODES[10647](VELOCITY_Y,0) = 0.000000; -NODES[10647](VELOCITY_Z,0) = 0.000000; -NODES[10648](VELOCITY_X,0) = 0.000000; -NODES[10648](VELOCITY_Y,0) = 0.000000; -NODES[10648](VELOCITY_Z,0) = 0.000000; -NODES[10649](VELOCITY_X,0) = 0.000000; -NODES[10649](VELOCITY_Y,0) = 0.000000; -NODES[10649](VELOCITY_Z,0) = 0.000000; -NODES[10650](VELOCITY_X,0) = 0.000000; -NODES[10650](VELOCITY_Y,0) = 0.000000; -NODES[10650](VELOCITY_Z,0) = 0.000000; -NODES[10654](VELOCITY_X,0) = 0.000000; -NODES[10654](VELOCITY_Y,0) = 0.000000; -NODES[10654](VELOCITY_Z,0) = 0.000000; -NODES[10663](VELOCITY_X,0) = 0.000000; -NODES[10663](VELOCITY_Y,0) = 0.000000; -NODES[10663](VELOCITY_Z,0) = 0.000000; -NODES[10665](VELOCITY_X,0) = 0.000000; -NODES[10665](VELOCITY_Y,0) = 0.000000; -NODES[10665](VELOCITY_Z,0) = 0.000000; -NODES[10667](VELOCITY_X,0) = 0.000000; -NODES[10667](VELOCITY_Y,0) = 0.000000; -NODES[10667](VELOCITY_Z,0) = 0.000000; -NODES[10682](VELOCITY_X,0) = 0.000000; -NODES[10682](VELOCITY_Y,0) = 0.000000; -NODES[10682](VELOCITY_Z,0) = 0.000000; -NODES[10683](VELOCITY_X,0) = 0.000000; -NODES[10683](VELOCITY_Y,0) = 0.000000; -NODES[10683](VELOCITY_Z,0) = 0.000000; -NODES[10684](VELOCITY_X,0) = 0.000000; -NODES[10684](VELOCITY_Y,0) = 0.000000; -NODES[10684](VELOCITY_Z,0) = 0.000000; -NODES[10685](VELOCITY_X,0) = 0.000000; -NODES[10685](VELOCITY_Y,0) = 0.000000; -NODES[10685](VELOCITY_Z,0) = 0.000000; -NODES[10687](VELOCITY_X,0) = 0.000000; -NODES[10687](VELOCITY_Y,0) = 0.000000; -NODES[10687](VELOCITY_Z,0) = 0.000000; -NODES[10691](VELOCITY_X,0) = 0.000000; -NODES[10691](VELOCITY_Y,0) = 0.000000; -NODES[10691](VELOCITY_Z,0) = 0.000000; -NODES[10692](VELOCITY_X,0) = 0.000000; -NODES[10692](VELOCITY_Y,0) = 0.000000; -NODES[10692](VELOCITY_Z,0) = 0.000000; -NODES[10693](VELOCITY_X,0) = 0.000000; -NODES[10693](VELOCITY_Y,0) = 0.000000; -NODES[10693](VELOCITY_Z,0) = 0.000000; -NODES[10694](VELOCITY_X,0) = 0.000000; -NODES[10694](VELOCITY_Y,0) = 0.000000; -NODES[10694](VELOCITY_Z,0) = 0.000000; -NODES[10710](VELOCITY_X,0) = 0.000000; -NODES[10710](VELOCITY_Y,0) = 0.000000; -NODES[10710](VELOCITY_Z,0) = 0.000000; -NODES[10715](VELOCITY_X,0) = 0.000000; -NODES[10715](VELOCITY_Y,0) = 0.000000; -NODES[10715](VELOCITY_Z,0) = 0.000000; -NODES[10721](VELOCITY_X,0) = 0.000000; -NODES[10721](VELOCITY_Y,0) = 0.000000; -NODES[10721](VELOCITY_Z,0) = 0.000000; -NODES[10731](VELOCITY_X,0) = 0.000000; -NODES[10731](VELOCITY_Y,0) = 0.000000; -NODES[10731](VELOCITY_Z,0) = 0.000000; -NODES[10732](VELOCITY_X,0) = 0.000000; -NODES[10732](VELOCITY_Y,0) = 0.000000; -NODES[10732](VELOCITY_Z,0) = 0.000000; -NODES[10733](VELOCITY_X,0) = 0.000000; -NODES[10733](VELOCITY_Y,0) = 0.000000; -NODES[10733](VELOCITY_Z,0) = 0.000000; -NODES[10734](VELOCITY_X,0) = 0.000000; -NODES[10734](VELOCITY_Y,0) = 0.000000; -NODES[10734](VELOCITY_Z,0) = 0.000000; -NODES[10735](VELOCITY_X,0) = 0.000000; -NODES[10735](VELOCITY_Y,0) = 0.000000; -NODES[10735](VELOCITY_Z,0) = 0.000000; -NODES[10736](VELOCITY_X,0) = 0.000000; -NODES[10736](VELOCITY_Y,0) = 0.000000; -NODES[10736](VELOCITY_Z,0) = 0.000000; -NODES[10748](VELOCITY_X,0) = 0.000000; -NODES[10748](VELOCITY_Y,0) = 0.000000; -NODES[10748](VELOCITY_Z,0) = 0.000000; -NODES[10751](VELOCITY_X,0) = 0.000000; -NODES[10751](VELOCITY_Y,0) = 0.000000; -NODES[10751](VELOCITY_Z,0) = 0.000000; -NODES[10758](VELOCITY_X,0) = 0.000000; -NODES[10758](VELOCITY_Y,0) = 0.000000; -NODES[10758](VELOCITY_Z,0) = 0.000000; -NODES[10759](VELOCITY_X,0) = 0.000000; -NODES[10759](VELOCITY_Y,0) = 0.000000; -NODES[10759](VELOCITY_Z,0) = 0.000000; -NODES[10762](VELOCITY_X,0) = 0.000000; -NODES[10762](VELOCITY_Y,0) = 0.000000; -NODES[10762](VELOCITY_Z,0) = 0.000000; -NODES[10763](VELOCITY_X,0) = 0.000000; -NODES[10763](VELOCITY_Y,0) = 0.000000; -NODES[10763](VELOCITY_Z,0) = 0.000000; -NODES[10787](VELOCITY_X,0) = 0.000000; -NODES[10787](VELOCITY_Y,0) = 0.000000; -NODES[10787](VELOCITY_Z,0) = 0.000000; -NODES[10792](VELOCITY_X,0) = 0.000000; -NODES[10792](VELOCITY_Y,0) = 0.000000; -NODES[10792](VELOCITY_Z,0) = 0.000000; -NODES[10793](VELOCITY_X,0) = 0.000000; -NODES[10793](VELOCITY_Y,0) = 0.000000; -NODES[10793](VELOCITY_Z,0) = 0.000000; -NODES[10798](VELOCITY_X,0) = 0.000000; -NODES[10798](VELOCITY_Y,0) = 0.000000; -NODES[10798](VELOCITY_Z,0) = 0.000000; -NODES[10799](VELOCITY_X,0) = 0.000000; -NODES[10799](VELOCITY_Y,0) = 0.000000; -NODES[10799](VELOCITY_Z,0) = 0.000000; -NODES[10802](VELOCITY_X,0) = 0.000000; -NODES[10802](VELOCITY_Y,0) = 0.000000; -NODES[10802](VELOCITY_Z,0) = 0.000000; -NODES[10804](VELOCITY_X,0) = 0.000000; -NODES[10804](VELOCITY_Y,0) = 0.000000; -NODES[10804](VELOCITY_Z,0) = 0.000000; -NODES[10808](VELOCITY_X,0) = 0.000000; -NODES[10808](VELOCITY_Y,0) = 0.000000; -NODES[10808](VELOCITY_Z,0) = 0.000000; -NODES[10816](VELOCITY_X,0) = 0.000000; -NODES[10816](VELOCITY_Y,0) = 0.000000; -NODES[10816](VELOCITY_Z,0) = 0.000000; -NODES[10827](VELOCITY_X,0) = 0.000000; -NODES[10827](VELOCITY_Y,0) = 0.000000; -NODES[10827](VELOCITY_Z,0) = 0.000000; -NODES[10828](VELOCITY_X,0) = 0.000000; -NODES[10828](VELOCITY_Y,0) = 0.000000; -NODES[10828](VELOCITY_Z,0) = 0.000000; -NODES[10832](VELOCITY_X,0) = 0.000000; -NODES[10832](VELOCITY_Y,0) = 0.000000; -NODES[10832](VELOCITY_Z,0) = 0.000000; -NODES[10836](VELOCITY_X,0) = 0.000000; -NODES[10836](VELOCITY_Y,0) = 0.000000; -NODES[10836](VELOCITY_Z,0) = 0.000000; -NODES[10842](VELOCITY_X,0) = 0.000000; -NODES[10842](VELOCITY_Y,0) = 0.000000; -NODES[10842](VELOCITY_Z,0) = 0.000000; -NODES[10843](VELOCITY_X,0) = 0.000000; -NODES[10843](VELOCITY_Y,0) = 0.000000; -NODES[10843](VELOCITY_Z,0) = 0.000000; -NODES[10863](VELOCITY_X,0) = 0.000000; -NODES[10863](VELOCITY_Y,0) = 0.000000; -NODES[10863](VELOCITY_Z,0) = 0.000000; -NODES[10871](VELOCITY_X,0) = 0.000000; -NODES[10871](VELOCITY_Y,0) = 0.000000; -NODES[10871](VELOCITY_Z,0) = 0.000000; -NODES[10877](VELOCITY_X,0) = 0.000000; -NODES[10877](VELOCITY_Y,0) = 0.000000; -NODES[10877](VELOCITY_Z,0) = 0.000000; -NODES[10878](VELOCITY_X,0) = 0.000000; -NODES[10878](VELOCITY_Y,0) = 0.000000; -NODES[10878](VELOCITY_Z,0) = 0.000000; -NODES[10879](VELOCITY_X,0) = 0.000000; -NODES[10879](VELOCITY_Y,0) = 0.000000; -NODES[10879](VELOCITY_Z,0) = 0.000000; -NODES[10884](VELOCITY_X,0) = 0.000000; -NODES[10884](VELOCITY_Y,0) = 0.000000; -NODES[10884](VELOCITY_Z,0) = 0.000000; -NODES[10885](VELOCITY_X,0) = 0.000000; -NODES[10885](VELOCITY_Y,0) = 0.000000; -NODES[10885](VELOCITY_Z,0) = 0.000000; -NODES[10892](VELOCITY_X,0) = 0.000000; -NODES[10892](VELOCITY_Y,0) = 0.000000; -NODES[10892](VELOCITY_Z,0) = 0.000000; -NODES[10913](VELOCITY_X,0) = 0.000000; -NODES[10913](VELOCITY_Y,0) = 0.000000; -NODES[10913](VELOCITY_Z,0) = 0.000000; -NODES[10917](VELOCITY_X,0) = 0.000000; -NODES[10917](VELOCITY_Y,0) = 0.000000; -NODES[10917](VELOCITY_Z,0) = 0.000000; -NODES[10929](VELOCITY_X,0) = 0.000000; -NODES[10929](VELOCITY_Y,0) = 0.000000; -NODES[10929](VELOCITY_Z,0) = 0.000000; -NODES[10934](VELOCITY_X,0) = 0.000000; -NODES[10934](VELOCITY_Y,0) = 0.000000; -NODES[10934](VELOCITY_Z,0) = 0.000000; -NODES[10935](VELOCITY_X,0) = 0.000000; -NODES[10935](VELOCITY_Y,0) = 0.000000; -NODES[10935](VELOCITY_Z,0) = 0.000000; -NODES[10936](VELOCITY_X,0) = 0.000000; -NODES[10936](VELOCITY_Y,0) = 0.000000; -NODES[10936](VELOCITY_Z,0) = 0.000000; -NODES[10938](VELOCITY_X,0) = 0.000000; -NODES[10938](VELOCITY_Y,0) = 0.000000; -NODES[10938](VELOCITY_Z,0) = 0.000000; -NODES[10944](VELOCITY_X,0) = 0.000000; -NODES[10944](VELOCITY_Y,0) = 0.000000; -NODES[10944](VELOCITY_Z,0) = 0.000000; -NODES[10947](VELOCITY_X,0) = 0.000000; -NODES[10947](VELOCITY_Y,0) = 0.000000; -NODES[10947](VELOCITY_Z,0) = 0.000000; -NODES[10950](VELOCITY_X,0) = 0.000000; -NODES[10950](VELOCITY_Y,0) = 0.000000; -NODES[10950](VELOCITY_Z,0) = 0.000000; -NODES[10952](VELOCITY_X,0) = 0.000000; -NODES[10952](VELOCITY_Y,0) = 0.000000; -NODES[10952](VELOCITY_Z,0) = 0.000000; -NODES[10963](VELOCITY_X,0) = 0.000000; -NODES[10963](VELOCITY_Y,0) = 0.000000; -NODES[10963](VELOCITY_Z,0) = 0.000000; -NODES[10971](VELOCITY_X,0) = 0.000000; -NODES[10971](VELOCITY_Y,0) = 0.000000; -NODES[10971](VELOCITY_Z,0) = 0.000000; -NODES[10972](VELOCITY_X,0) = 0.000000; -NODES[10972](VELOCITY_Y,0) = 0.000000; -NODES[10972](VELOCITY_Z,0) = 0.000000; -NODES[10979](VELOCITY_X,0) = 0.000000; -NODES[10979](VELOCITY_Y,0) = 0.000000; -NODES[10979](VELOCITY_Z,0) = 0.000000; -NODES[10980](VELOCITY_X,0) = 0.000000; -NODES[10980](VELOCITY_Y,0) = 0.000000; -NODES[10980](VELOCITY_Z,0) = 0.000000; -NODES[10991](VELOCITY_X,0) = 0.000000; -NODES[10991](VELOCITY_Y,0) = 0.000000; -NODES[10991](VELOCITY_Z,0) = 0.000000; -NODES[10992](VELOCITY_X,0) = 0.000000; -NODES[10992](VELOCITY_Y,0) = 0.000000; -NODES[10992](VELOCITY_Z,0) = 0.000000; -NODES[10995](VELOCITY_X,0) = 0.000000; -NODES[10995](VELOCITY_Y,0) = 0.000000; -NODES[10995](VELOCITY_Z,0) = 0.000000; -NODES[10996](VELOCITY_X,0) = 0.000000; -NODES[10996](VELOCITY_Y,0) = 0.000000; -NODES[10996](VELOCITY_Z,0) = 0.000000; -NODES[10997](VELOCITY_X,0) = 0.000000; -NODES[10997](VELOCITY_Y,0) = 0.000000; -NODES[10997](VELOCITY_Z,0) = 0.000000; -NODES[11015](VELOCITY_X,0) = 0.000000; -NODES[11015](VELOCITY_Y,0) = 0.000000; -NODES[11015](VELOCITY_Z,0) = 0.000000; -NODES[11017](VELOCITY_X,0) = 0.000000; -NODES[11017](VELOCITY_Y,0) = 0.000000; -NODES[11017](VELOCITY_Z,0) = 0.000000; -NODES[11036](VELOCITY_X,0) = 0.000000; -NODES[11036](VELOCITY_Y,0) = 0.000000; -NODES[11036](VELOCITY_Z,0) = 0.000000; -NODES[11047](VELOCITY_X,0) = 0.000000; -NODES[11047](VELOCITY_Y,0) = 0.000000; -NODES[11047](VELOCITY_Z,0) = 0.000000; -NODES[11065](VELOCITY_X,0) = 0.000000; -NODES[11065](VELOCITY_Y,0) = 0.000000; -NODES[11065](VELOCITY_Z,0) = 0.000000; -NODES[11075](VELOCITY_X,0) = 0.000000; -NODES[11075](VELOCITY_Y,0) = 0.000000; -NODES[11075](VELOCITY_Z,0) = 0.000000; -NODES[11078](VELOCITY_X,0) = 0.000000; -NODES[11078](VELOCITY_Y,0) = 0.000000; -NODES[11078](VELOCITY_Z,0) = 0.000000; -NODES[11090](VELOCITY_X,0) = 0.000000; -NODES[11090](VELOCITY_Y,0) = 0.000000; -NODES[11090](VELOCITY_Z,0) = 0.000000; -NODES[11092](VELOCITY_X,0) = 0.000000; -NODES[11092](VELOCITY_Y,0) = 0.000000; -NODES[11092](VELOCITY_Z,0) = 0.000000; -NODES[11093](VELOCITY_X,0) = 0.000000; -NODES[11093](VELOCITY_Y,0) = 0.000000; -NODES[11093](VELOCITY_Z,0) = 0.000000; -NODES[11100](VELOCITY_X,0) = 0.000000; -NODES[11100](VELOCITY_Y,0) = 0.000000; -NODES[11100](VELOCITY_Z,0) = 0.000000; -NODES[11101](VELOCITY_X,0) = 0.000000; -NODES[11101](VELOCITY_Y,0) = 0.000000; -NODES[11101](VELOCITY_Z,0) = 0.000000; -NODES[11106](VELOCITY_X,0) = 0.000000; -NODES[11106](VELOCITY_Y,0) = 0.000000; -NODES[11106](VELOCITY_Z,0) = 0.000000; -NODES[11107](VELOCITY_X,0) = 0.000000; -NODES[11107](VELOCITY_Y,0) = 0.000000; -NODES[11107](VELOCITY_Z,0) = 0.000000; -NODES[11112](VELOCITY_X,0) = 0.000000; -NODES[11112](VELOCITY_Y,0) = 0.000000; -NODES[11112](VELOCITY_Z,0) = 0.000000; -NODES[11113](VELOCITY_X,0) = 0.000000; -NODES[11113](VELOCITY_Y,0) = 0.000000; -NODES[11113](VELOCITY_Z,0) = 0.000000; -NODES[11125](VELOCITY_X,0) = 0.000000; -NODES[11125](VELOCITY_Y,0) = 0.000000; -NODES[11125](VELOCITY_Z,0) = 0.000000; -NODES[11126](VELOCITY_X,0) = 0.000000; -NODES[11126](VELOCITY_Y,0) = 0.000000; -NODES[11126](VELOCITY_Z,0) = 0.000000; -NODES[11127](VELOCITY_X,0) = 0.000000; -NODES[11127](VELOCITY_Y,0) = 0.000000; -NODES[11127](VELOCITY_Z,0) = 0.000000; -NODES[11137](VELOCITY_X,0) = 0.000000; -NODES[11137](VELOCITY_Y,0) = 0.000000; -NODES[11137](VELOCITY_Z,0) = 0.000000; -NODES[11139](VELOCITY_X,0) = 0.000000; -NODES[11139](VELOCITY_Y,0) = 0.000000; -NODES[11139](VELOCITY_Z,0) = 0.000000; -NODES[11140](VELOCITY_X,0) = 0.000000; -NODES[11140](VELOCITY_Y,0) = 0.000000; -NODES[11140](VELOCITY_Z,0) = 0.000000; -NODES[11141](VELOCITY_X,0) = 0.000000; -NODES[11141](VELOCITY_Y,0) = 0.000000; -NODES[11141](VELOCITY_Z,0) = 0.000000; -NODES[11142](VELOCITY_X,0) = 0.000000; -NODES[11142](VELOCITY_Y,0) = 0.000000; -NODES[11142](VELOCITY_Z,0) = 0.000000; -NODES[11143](VELOCITY_X,0) = 0.000000; -NODES[11143](VELOCITY_Y,0) = 0.000000; -NODES[11143](VELOCITY_Z,0) = 0.000000; -NODES[11151](VELOCITY_X,0) = 0.000000; -NODES[11151](VELOCITY_Y,0) = 0.000000; -NODES[11151](VELOCITY_Z,0) = 0.000000; -NODES[11154](VELOCITY_X,0) = 0.000000; -NODES[11154](VELOCITY_Y,0) = 0.000000; -NODES[11154](VELOCITY_Z,0) = 0.000000; -NODES[11155](VELOCITY_X,0) = 0.000000; -NODES[11155](VELOCITY_Y,0) = 0.000000; -NODES[11155](VELOCITY_Z,0) = 0.000000; -NODES[11156](VELOCITY_X,0) = 0.000000; -NODES[11156](VELOCITY_Y,0) = 0.000000; -NODES[11156](VELOCITY_Z,0) = 0.000000; -NODES[11157](VELOCITY_X,0) = 0.000000; -NODES[11157](VELOCITY_Y,0) = 0.000000; -NODES[11157](VELOCITY_Z,0) = 0.000000; -NODES[11165](VELOCITY_X,0) = 0.000000; -NODES[11165](VELOCITY_Y,0) = 0.000000; -NODES[11165](VELOCITY_Z,0) = 0.000000; -NODES[11176](VELOCITY_X,0) = 0.000000; -NODES[11176](VELOCITY_Y,0) = 0.000000; -NODES[11176](VELOCITY_Z,0) = 0.000000; -NODES[11179](VELOCITY_X,0) = 0.000000; -NODES[11179](VELOCITY_Y,0) = 0.000000; -NODES[11179](VELOCITY_Z,0) = 0.000000; -NODES[11180](VELOCITY_X,0) = 0.000000; -NODES[11180](VELOCITY_Y,0) = 0.000000; -NODES[11180](VELOCITY_Z,0) = 0.000000; -NODES[11192](VELOCITY_X,0) = 0.000000; -NODES[11192](VELOCITY_Y,0) = 0.000000; -NODES[11192](VELOCITY_Z,0) = 0.000000; -NODES[11193](VELOCITY_X,0) = 0.000000; -NODES[11193](VELOCITY_Y,0) = 0.000000; -NODES[11193](VELOCITY_Z,0) = 0.000000; -NODES[11194](VELOCITY_X,0) = 0.000000; -NODES[11194](VELOCITY_Y,0) = 0.000000; -NODES[11194](VELOCITY_Z,0) = 0.000000; -NODES[11195](VELOCITY_X,0) = 0.000000; -NODES[11195](VELOCITY_Y,0) = 0.000000; -NODES[11195](VELOCITY_Z,0) = 0.000000; -NODES[11202](VELOCITY_X,0) = 0.000000; -NODES[11202](VELOCITY_Y,0) = 0.000000; -NODES[11202](VELOCITY_Z,0) = 0.000000; -NODES[11213](VELOCITY_X,0) = 0.000000; -NODES[11213](VELOCITY_Y,0) = 0.000000; -NODES[11213](VELOCITY_Z,0) = 0.000000; -NODES[11227](VELOCITY_X,0) = 0.000000; -NODES[11227](VELOCITY_Y,0) = 0.000000; -NODES[11227](VELOCITY_Z,0) = 0.000000; -NODES[11247](VELOCITY_X,0) = 0.000000; -NODES[11247](VELOCITY_Y,0) = 0.000000; -NODES[11247](VELOCITY_Z,0) = 0.000000; -NODES[11250](VELOCITY_X,0) = 0.000000; -NODES[11250](VELOCITY_Y,0) = 0.000000; -NODES[11250](VELOCITY_Z,0) = 0.000000; -NODES[11251](VELOCITY_X,0) = 0.000000; -NODES[11251](VELOCITY_Y,0) = 0.000000; -NODES[11251](VELOCITY_Z,0) = 0.000000; -NODES[11252](VELOCITY_X,0) = 0.000000; -NODES[11252](VELOCITY_Y,0) = 0.000000; -NODES[11252](VELOCITY_Z,0) = 0.000000; -NODES[11262](VELOCITY_X,0) = 0.000000; -NODES[11262](VELOCITY_Y,0) = 0.000000; -NODES[11262](VELOCITY_Z,0) = 0.000000; -NODES[11263](VELOCITY_X,0) = 0.000000; -NODES[11263](VELOCITY_Y,0) = 0.000000; -NODES[11263](VELOCITY_Z,0) = 0.000000; -NODES[11264](VELOCITY_X,0) = 0.000000; -NODES[11264](VELOCITY_Y,0) = 0.000000; -NODES[11264](VELOCITY_Z,0) = 0.000000; -NODES[11265](VELOCITY_X,0) = 0.000000; -NODES[11265](VELOCITY_Y,0) = 0.000000; -NODES[11265](VELOCITY_Z,0) = 0.000000; -NODES[11266](VELOCITY_X,0) = 0.000000; -NODES[11266](VELOCITY_Y,0) = 0.000000; -NODES[11266](VELOCITY_Z,0) = 0.000000; -NODES[11270](VELOCITY_X,0) = 0.000000; -NODES[11270](VELOCITY_Y,0) = 0.000000; -NODES[11270](VELOCITY_Z,0) = 0.000000; -NODES[11302](VELOCITY_X,0) = 0.000000; -NODES[11302](VELOCITY_Y,0) = 0.000000; -NODES[11302](VELOCITY_Z,0) = 0.000000; -NODES[11309](VELOCITY_X,0) = 0.000000; -NODES[11309](VELOCITY_Y,0) = 0.000000; -NODES[11309](VELOCITY_Z,0) = 0.000000; -NODES[11319](VELOCITY_X,0) = 0.000000; -NODES[11319](VELOCITY_Y,0) = 0.000000; -NODES[11319](VELOCITY_Z,0) = 0.000000; -NODES[11329](VELOCITY_X,0) = 0.000000; -NODES[11329](VELOCITY_Y,0) = 0.000000; -NODES[11329](VELOCITY_Z,0) = 0.000000; -NODES[11334](VELOCITY_X,0) = 0.000000; -NODES[11334](VELOCITY_Y,0) = 0.000000; -NODES[11334](VELOCITY_Z,0) = 0.000000; -NODES[11337](VELOCITY_X,0) = 0.000000; -NODES[11337](VELOCITY_Y,0) = 0.000000; -NODES[11337](VELOCITY_Z,0) = 0.000000; -NODES[11338](VELOCITY_X,0) = 0.000000; -NODES[11338](VELOCITY_Y,0) = 0.000000; -NODES[11338](VELOCITY_Z,0) = 0.000000; -NODES[11340](VELOCITY_X,0) = 0.000000; -NODES[11340](VELOCITY_Y,0) = 0.000000; -NODES[11340](VELOCITY_Z,0) = 0.000000; -NODES[11343](VELOCITY_X,0) = 0.000000; -NODES[11343](VELOCITY_Y,0) = 0.000000; -NODES[11343](VELOCITY_Z,0) = 0.000000; -NODES[11353](VELOCITY_X,0) = 0.000000; -NODES[11353](VELOCITY_Y,0) = 0.000000; -NODES[11353](VELOCITY_Z,0) = 0.000000; -NODES[11354](VELOCITY_X,0) = 0.000000; -NODES[11354](VELOCITY_Y,0) = 0.000000; -NODES[11354](VELOCITY_Z,0) = 0.000000; -NODES[11355](VELOCITY_X,0) = 0.000000; -NODES[11355](VELOCITY_Y,0) = 0.000000; -NODES[11355](VELOCITY_Z,0) = 0.000000; -NODES[11356](VELOCITY_X,0) = 0.000000; -NODES[11356](VELOCITY_Y,0) = 0.000000; -NODES[11356](VELOCITY_Z,0) = 0.000000; -NODES[11357](VELOCITY_X,0) = 0.000000; -NODES[11357](VELOCITY_Y,0) = 0.000000; -NODES[11357](VELOCITY_Z,0) = 0.000000; -NODES[11361](VELOCITY_X,0) = 0.000000; -NODES[11361](VELOCITY_Y,0) = 0.000000; -NODES[11361](VELOCITY_Z,0) = 0.000000; -NODES[11368](VELOCITY_X,0) = 0.000000; -NODES[11368](VELOCITY_Y,0) = 0.000000; -NODES[11368](VELOCITY_Z,0) = 0.000000; -NODES[11370](VELOCITY_X,0) = 0.000000; -NODES[11370](VELOCITY_Y,0) = 0.000000; -NODES[11370](VELOCITY_Z,0) = 0.000000; -NODES[11372](VELOCITY_X,0) = 0.000000; -NODES[11372](VELOCITY_Y,0) = 0.000000; -NODES[11372](VELOCITY_Z,0) = 0.000000; -NODES[11384](VELOCITY_X,0) = 0.000000; -NODES[11384](VELOCITY_Y,0) = 0.000000; -NODES[11384](VELOCITY_Z,0) = 0.000000; -NODES[11408](VELOCITY_X,0) = 0.000000; -NODES[11408](VELOCITY_Y,0) = 0.000000; -NODES[11408](VELOCITY_Z,0) = 0.000000; -NODES[11414](VELOCITY_X,0) = 0.000000; -NODES[11414](VELOCITY_Y,0) = 0.000000; -NODES[11414](VELOCITY_Z,0) = 0.000000; -NODES[11426](VELOCITY_X,0) = 0.000000; -NODES[11426](VELOCITY_Y,0) = 0.000000; -NODES[11426](VELOCITY_Z,0) = 0.000000; -NODES[11427](VELOCITY_X,0) = 0.000000; -NODES[11427](VELOCITY_Y,0) = 0.000000; -NODES[11427](VELOCITY_Z,0) = 0.000000; -NODES[11431](VELOCITY_X,0) = 0.000000; -NODES[11431](VELOCITY_Y,0) = 0.000000; -NODES[11431](VELOCITY_Z,0) = 0.000000; -NODES[11437](VELOCITY_X,0) = 0.000000; -NODES[11437](VELOCITY_Y,0) = 0.000000; -NODES[11437](VELOCITY_Z,0) = 0.000000; -NODES[11464](VELOCITY_X,0) = 0.000000; -NODES[11464](VELOCITY_Y,0) = 0.000000; -NODES[11464](VELOCITY_Z,0) = 0.000000; -NODES[11465](VELOCITY_X,0) = 0.000000; -NODES[11465](VELOCITY_Y,0) = 0.000000; -NODES[11465](VELOCITY_Z,0) = 0.000000; -NODES[11466](VELOCITY_X,0) = 0.000000; -NODES[11466](VELOCITY_Y,0) = 0.000000; -NODES[11466](VELOCITY_Z,0) = 0.000000; -NODES[11467](VELOCITY_X,0) = 0.000000; -NODES[11467](VELOCITY_Y,0) = 0.000000; -NODES[11467](VELOCITY_Z,0) = 0.000000; -NODES[11468](VELOCITY_X,0) = 0.000000; -NODES[11468](VELOCITY_Y,0) = 0.000000; -NODES[11468](VELOCITY_Z,0) = 0.000000; -NODES[11469](VELOCITY_X,0) = 0.000000; -NODES[11469](VELOCITY_Y,0) = 0.000000; -NODES[11469](VELOCITY_Z,0) = 0.000000; -NODES[11471](VELOCITY_X,0) = 0.000000; -NODES[11471](VELOCITY_Y,0) = 0.000000; -NODES[11471](VELOCITY_Z,0) = 0.000000; -NODES[11472](VELOCITY_X,0) = 0.000000; -NODES[11472](VELOCITY_Y,0) = 0.000000; -NODES[11472](VELOCITY_Z,0) = 0.000000; -NODES[11476](VELOCITY_X,0) = 0.000000; -NODES[11476](VELOCITY_Y,0) = 0.000000; -NODES[11476](VELOCITY_Z,0) = 0.000000; -NODES[11486](VELOCITY_X,0) = 0.000000; -NODES[11486](VELOCITY_Y,0) = 0.000000; -NODES[11486](VELOCITY_Z,0) = 0.000000; -NODES[11487](VELOCITY_X,0) = 0.000000; -NODES[11487](VELOCITY_Y,0) = 0.000000; -NODES[11487](VELOCITY_Z,0) = 0.000000; -NODES[11491](VELOCITY_X,0) = 0.000000; -NODES[11491](VELOCITY_Y,0) = 0.000000; -NODES[11491](VELOCITY_Z,0) = 0.000000; -NODES[11493](VELOCITY_X,0) = 0.000000; -NODES[11493](VELOCITY_Y,0) = 0.000000; -NODES[11493](VELOCITY_Z,0) = 0.000000; -NODES[11494](VELOCITY_X,0) = 0.000000; -NODES[11494](VELOCITY_Y,0) = 0.000000; -NODES[11494](VELOCITY_Z,0) = 0.000000; -NODES[11502](VELOCITY_X,0) = 0.000000; -NODES[11502](VELOCITY_Y,0) = 0.000000; -NODES[11502](VELOCITY_Z,0) = 0.000000; -NODES[11507](VELOCITY_X,0) = 0.000000; -NODES[11507](VELOCITY_Y,0) = 0.000000; -NODES[11507](VELOCITY_Z,0) = 0.000000; -NODES[11510](VELOCITY_X,0) = 0.000000; -NODES[11510](VELOCITY_Y,0) = 0.000000; -NODES[11510](VELOCITY_Z,0) = 0.000000; -NODES[11513](VELOCITY_X,0) = 0.000000; -NODES[11513](VELOCITY_Y,0) = 0.000000; -NODES[11513](VELOCITY_Z,0) = 0.000000; -NODES[11527](VELOCITY_X,0) = 0.000000; -NODES[11527](VELOCITY_Y,0) = 0.000000; -NODES[11527](VELOCITY_Z,0) = 0.000000; -NODES[11528](VELOCITY_X,0) = 0.000000; -NODES[11528](VELOCITY_Y,0) = 0.000000; -NODES[11528](VELOCITY_Z,0) = 0.000000; -NODES[11531](VELOCITY_X,0) = 0.000000; -NODES[11531](VELOCITY_Y,0) = 0.000000; -NODES[11531](VELOCITY_Z,0) = 0.000000; -NODES[11550](VELOCITY_X,0) = 0.000000; -NODES[11550](VELOCITY_Y,0) = 0.000000; -NODES[11550](VELOCITY_Z,0) = 0.000000; -NODES[11563](VELOCITY_X,0) = 0.000000; -NODES[11563](VELOCITY_Y,0) = 0.000000; -NODES[11563](VELOCITY_Z,0) = 0.000000; -NODES[11564](VELOCITY_X,0) = 0.000000; -NODES[11564](VELOCITY_Y,0) = 0.000000; -NODES[11564](VELOCITY_Z,0) = 0.000000; -NODES[11569](VELOCITY_X,0) = 0.000000; -NODES[11569](VELOCITY_Y,0) = 0.000000; -NODES[11569](VELOCITY_Z,0) = 0.000000; -NODES[11574](VELOCITY_X,0) = 0.000000; -NODES[11574](VELOCITY_Y,0) = 0.000000; -NODES[11574](VELOCITY_Z,0) = 0.000000; -NODES[11584](VELOCITY_X,0) = 0.000000; -NODES[11584](VELOCITY_Y,0) = 0.000000; -NODES[11584](VELOCITY_Z,0) = 0.000000; -NODES[11585](VELOCITY_X,0) = 0.000000; -NODES[11585](VELOCITY_Y,0) = 0.000000; -NODES[11585](VELOCITY_Z,0) = 0.000000; -NODES[11586](VELOCITY_X,0) = 0.000000; -NODES[11586](VELOCITY_Y,0) = 0.000000; -NODES[11586](VELOCITY_Z,0) = 0.000000; -NODES[11596](VELOCITY_X,0) = 0.000000; -NODES[11596](VELOCITY_Y,0) = 0.000000; -NODES[11596](VELOCITY_Z,0) = 0.000000; -NODES[11597](VELOCITY_X,0) = 0.000000; -NODES[11597](VELOCITY_Y,0) = 0.000000; -NODES[11597](VELOCITY_Z,0) = 0.000000; -NODES[11598](VELOCITY_X,0) = 0.000000; -NODES[11598](VELOCITY_Y,0) = 0.000000; -NODES[11598](VELOCITY_Z,0) = 0.000000; -NODES[11599](VELOCITY_X,0) = 0.000000; -NODES[11599](VELOCITY_Y,0) = 0.000000; -NODES[11599](VELOCITY_Z,0) = 0.000000; -NODES[11600](VELOCITY_X,0) = 0.000000; -NODES[11600](VELOCITY_Y,0) = 0.000000; -NODES[11600](VELOCITY_Z,0) = 0.000000; -NODES[11606](VELOCITY_X,0) = 0.000000; -NODES[11606](VELOCITY_Y,0) = 0.000000; -NODES[11606](VELOCITY_Z,0) = 0.000000; -NODES[11624](VELOCITY_X,0) = 0.000000; -NODES[11624](VELOCITY_Y,0) = 0.000000; -NODES[11624](VELOCITY_Z,0) = 0.000000; -NODES[11625](VELOCITY_X,0) = 0.000000; -NODES[11625](VELOCITY_Y,0) = 0.000000; -NODES[11625](VELOCITY_Z,0) = 0.000000; -NODES[11626](VELOCITY_X,0) = 0.000000; -NODES[11626](VELOCITY_Y,0) = 0.000000; -NODES[11626](VELOCITY_Z,0) = 0.000000; -NODES[11627](VELOCITY_X,0) = 0.000000; -NODES[11627](VELOCITY_Y,0) = 0.000000; -NODES[11627](VELOCITY_Z,0) = 0.000000; -NODES[11633](VELOCITY_X,0) = 0.000000; -NODES[11633](VELOCITY_Y,0) = 0.000000; -NODES[11633](VELOCITY_Z,0) = 0.000000; -NODES[11642](VELOCITY_X,0) = 0.000000; -NODES[11642](VELOCITY_Y,0) = 0.000000; -NODES[11642](VELOCITY_Z,0) = 0.000000; -NODES[11644](VELOCITY_X,0) = 0.000000; -NODES[11644](VELOCITY_Y,0) = 0.000000; -NODES[11644](VELOCITY_Z,0) = 0.000000; -NODES[11651](VELOCITY_X,0) = 0.000000; -NODES[11651](VELOCITY_Y,0) = 0.000000; -NODES[11651](VELOCITY_Z,0) = 0.000000; -NODES[11655](VELOCITY_X,0) = 0.000000; -NODES[11655](VELOCITY_Y,0) = 0.000000; -NODES[11655](VELOCITY_Z,0) = 0.000000; -NODES[11659](VELOCITY_X,0) = 0.000000; -NODES[11659](VELOCITY_Y,0) = 0.000000; -NODES[11659](VELOCITY_Z,0) = 0.000000; -NODES[11660](VELOCITY_X,0) = 0.000000; -NODES[11660](VELOCITY_Y,0) = 0.000000; -NODES[11660](VELOCITY_Z,0) = 0.000000; -NODES[11661](VELOCITY_X,0) = 0.000000; -NODES[11661](VELOCITY_Y,0) = 0.000000; -NODES[11661](VELOCITY_Z,0) = 0.000000; -NODES[11662](VELOCITY_X,0) = 0.000000; -NODES[11662](VELOCITY_Y,0) = 0.000000; -NODES[11662](VELOCITY_Z,0) = 0.000000; -NODES[11667](VELOCITY_X,0) = 0.000000; -NODES[11667](VELOCITY_Y,0) = 0.000000; -NODES[11667](VELOCITY_Z,0) = 0.000000; -NODES[11677](VELOCITY_X,0) = 0.000000; -NODES[11677](VELOCITY_Y,0) = 0.000000; -NODES[11677](VELOCITY_Z,0) = 0.000000; -NODES[11678](VELOCITY_X,0) = 0.000000; -NODES[11678](VELOCITY_Y,0) = 0.000000; -NODES[11678](VELOCITY_Z,0) = 0.000000; -NODES[11679](VELOCITY_X,0) = 0.000000; -NODES[11679](VELOCITY_Y,0) = 0.000000; -NODES[11679](VELOCITY_Z,0) = 0.000000; -NODES[11684](VELOCITY_X,0) = 0.000000; -NODES[11684](VELOCITY_Y,0) = 0.000000; -NODES[11684](VELOCITY_Z,0) = 0.000000; -NODES[11685](VELOCITY_X,0) = 0.000000; -NODES[11685](VELOCITY_Y,0) = 0.000000; -NODES[11685](VELOCITY_Z,0) = 0.000000; -NODES[11695](VELOCITY_X,0) = 0.000000; -NODES[11695](VELOCITY_Y,0) = 0.000000; -NODES[11695](VELOCITY_Z,0) = 0.000000; -NODES[11700](VELOCITY_X,0) = 0.000000; -NODES[11700](VELOCITY_Y,0) = 0.000000; -NODES[11700](VELOCITY_Z,0) = 0.000000; -NODES[11711](VELOCITY_X,0) = 0.000000; -NODES[11711](VELOCITY_Y,0) = 0.000000; -NODES[11711](VELOCITY_Z,0) = 0.000000; -NODES[11720](VELOCITY_X,0) = 0.000000; -NODES[11720](VELOCITY_Y,0) = 0.000000; -NODES[11720](VELOCITY_Z,0) = 0.000000; -NODES[11734](VELOCITY_X,0) = 0.000000; -NODES[11734](VELOCITY_Y,0) = 0.000000; -NODES[11734](VELOCITY_Z,0) = 0.000000; -NODES[11736](VELOCITY_X,0) = 0.000000; -NODES[11736](VELOCITY_Y,0) = 0.000000; -NODES[11736](VELOCITY_Z,0) = 0.000000; -NODES[11738](VELOCITY_X,0) = 0.000000; -NODES[11738](VELOCITY_Y,0) = 0.000000; -NODES[11738](VELOCITY_Z,0) = 0.000000; -NODES[11740](VELOCITY_X,0) = 0.000000; -NODES[11740](VELOCITY_Y,0) = 0.000000; -NODES[11740](VELOCITY_Z,0) = 0.000000; -NODES[11751](VELOCITY_X,0) = 0.000000; -NODES[11751](VELOCITY_Y,0) = 0.000000; -NODES[11751](VELOCITY_Z,0) = 0.000000; -NODES[11752](VELOCITY_X,0) = 0.000000; -NODES[11752](VELOCITY_Y,0) = 0.000000; -NODES[11752](VELOCITY_Z,0) = 0.000000; -NODES[11753](VELOCITY_X,0) = 0.000000; -NODES[11753](VELOCITY_Y,0) = 0.000000; -NODES[11753](VELOCITY_Z,0) = 0.000000; -NODES[11754](VELOCITY_X,0) = 0.000000; -NODES[11754](VELOCITY_Y,0) = 0.000000; -NODES[11754](VELOCITY_Z,0) = 0.000000; -NODES[11761](VELOCITY_X,0) = 0.000000; -NODES[11761](VELOCITY_Y,0) = 0.000000; -NODES[11761](VELOCITY_Z,0) = 0.000000; -NODES[11792](VELOCITY_X,0) = 0.000000; -NODES[11792](VELOCITY_Y,0) = 0.000000; -NODES[11792](VELOCITY_Z,0) = 0.000000; -NODES[11793](VELOCITY_X,0) = 0.000000; -NODES[11793](VELOCITY_Y,0) = 0.000000; -NODES[11793](VELOCITY_Z,0) = 0.000000; -NODES[11803](VELOCITY_X,0) = 0.000000; -NODES[11803](VELOCITY_Y,0) = 0.000000; -NODES[11803](VELOCITY_Z,0) = 0.000000; -NODES[11806](VELOCITY_X,0) = 0.000000; -NODES[11806](VELOCITY_Y,0) = 0.000000; -NODES[11806](VELOCITY_Z,0) = 0.000000; -NODES[11817](VELOCITY_X,0) = 0.000000; -NODES[11817](VELOCITY_Y,0) = 0.000000; -NODES[11817](VELOCITY_Z,0) = 0.000000; -NODES[11822](VELOCITY_X,0) = 0.000000; -NODES[11822](VELOCITY_Y,0) = 0.000000; -NODES[11822](VELOCITY_Z,0) = 0.000000; -NODES[11826](VELOCITY_X,0) = 0.000000; -NODES[11826](VELOCITY_Y,0) = 0.000000; -NODES[11826](VELOCITY_Z,0) = 0.000000; -NODES[11827](VELOCITY_X,0) = 0.000000; -NODES[11827](VELOCITY_Y,0) = 0.000000; -NODES[11827](VELOCITY_Z,0) = 0.000000; -NODES[11828](VELOCITY_X,0) = 0.000000; -NODES[11828](VELOCITY_Y,0) = 0.000000; -NODES[11828](VELOCITY_Z,0) = 0.000000; -NODES[11831](VELOCITY_X,0) = 0.000000; -NODES[11831](VELOCITY_Y,0) = 0.000000; -NODES[11831](VELOCITY_Z,0) = 0.000000; -NODES[11836](VELOCITY_X,0) = 0.000000; -NODES[11836](VELOCITY_Y,0) = 0.000000; -NODES[11836](VELOCITY_Z,0) = 0.000000; -NODES[11845](VELOCITY_X,0) = 0.000000; -NODES[11845](VELOCITY_Y,0) = 0.000000; -NODES[11845](VELOCITY_Z,0) = 0.000000; -NODES[11846](VELOCITY_X,0) = 0.000000; -NODES[11846](VELOCITY_Y,0) = 0.000000; -NODES[11846](VELOCITY_Z,0) = 0.000000; -NODES[11865](VELOCITY_X,0) = 0.000000; -NODES[11865](VELOCITY_Y,0) = 0.000000; -NODES[11865](VELOCITY_Z,0) = 0.000000; -NODES[11867](VELOCITY_X,0) = 0.000000; -NODES[11867](VELOCITY_Y,0) = 0.000000; -NODES[11867](VELOCITY_Z,0) = 0.000000; -NODES[11873](VELOCITY_X,0) = 0.000000; -NODES[11873](VELOCITY_Y,0) = 0.000000; -NODES[11873](VELOCITY_Z,0) = 0.000000; -NODES[11877](VELOCITY_X,0) = 0.000000; -NODES[11877](VELOCITY_Y,0) = 0.000000; -NODES[11877](VELOCITY_Z,0) = 0.000000; -NODES[11910](VELOCITY_X,0) = 0.000000; -NODES[11910](VELOCITY_Y,0) = 0.000000; -NODES[11910](VELOCITY_Z,0) = 0.000000; -NODES[11915](VELOCITY_X,0) = 0.000000; -NODES[11915](VELOCITY_Y,0) = 0.000000; -NODES[11915](VELOCITY_Z,0) = 0.000000; -NODES[11916](VELOCITY_X,0) = 0.000000; -NODES[11916](VELOCITY_Y,0) = 0.000000; -NODES[11916](VELOCITY_Z,0) = 0.000000; -NODES[11919](VELOCITY_X,0) = 0.000000; -NODES[11919](VELOCITY_Y,0) = 0.000000; -NODES[11919](VELOCITY_Z,0) = 0.000000; -NODES[11937](VELOCITY_X,0) = 0.000000; -NODES[11937](VELOCITY_Y,0) = 0.000000; -NODES[11937](VELOCITY_Z,0) = 0.000000; -NODES[11938](VELOCITY_X,0) = 0.000000; -NODES[11938](VELOCITY_Y,0) = 0.000000; -NODES[11938](VELOCITY_Z,0) = 0.000000; -NODES[11939](VELOCITY_X,0) = 0.000000; -NODES[11939](VELOCITY_Y,0) = 0.000000; -NODES[11939](VELOCITY_Z,0) = 0.000000; -NODES[11940](VELOCITY_X,0) = 0.000000; -NODES[11940](VELOCITY_Y,0) = 0.000000; -NODES[11940](VELOCITY_Z,0) = 0.000000; -NODES[11953](VELOCITY_X,0) = 0.000000; -NODES[11953](VELOCITY_Y,0) = 0.000000; -NODES[11953](VELOCITY_Z,0) = 0.000000; -NODES[11960](VELOCITY_X,0) = 0.000000; -NODES[11960](VELOCITY_Y,0) = 0.000000; -NODES[11960](VELOCITY_Z,0) = 0.000000; -NODES[11961](VELOCITY_X,0) = 0.000000; -NODES[11961](VELOCITY_Y,0) = 0.000000; -NODES[11961](VELOCITY_Z,0) = 0.000000; -NODES[11967](VELOCITY_X,0) = 0.000000; -NODES[11967](VELOCITY_Y,0) = 0.000000; -NODES[11967](VELOCITY_Z,0) = 0.000000; -NODES[11971](VELOCITY_X,0) = 0.000000; -NODES[11971](VELOCITY_Y,0) = 0.000000; -NODES[11971](VELOCITY_Z,0) = 0.000000; -NODES[11985](VELOCITY_X,0) = 0.000000; -NODES[11985](VELOCITY_Y,0) = 0.000000; -NODES[11985](VELOCITY_Z,0) = 0.000000; -NODES[11991](VELOCITY_X,0) = 0.000000; -NODES[11991](VELOCITY_Y,0) = 0.000000; -NODES[11991](VELOCITY_Z,0) = 0.000000; -NODES[12003](VELOCITY_X,0) = 0.000000; -NODES[12003](VELOCITY_Y,0) = 0.000000; -NODES[12003](VELOCITY_Z,0) = 0.000000; -NODES[12006](VELOCITY_X,0) = 0.000000; -NODES[12006](VELOCITY_Y,0) = 0.000000; -NODES[12006](VELOCITY_Z,0) = 0.000000; -NODES[12013](VELOCITY_X,0) = 0.000000; -NODES[12013](VELOCITY_Y,0) = 0.000000; -NODES[12013](VELOCITY_Z,0) = 0.000000; -NODES[12028](VELOCITY_X,0) = 0.000000; -NODES[12028](VELOCITY_Y,0) = 0.000000; -NODES[12028](VELOCITY_Z,0) = 0.000000; -NODES[12030](VELOCITY_X,0) = 0.000000; -NODES[12030](VELOCITY_Y,0) = 0.000000; -NODES[12030](VELOCITY_Z,0) = 0.000000; -NODES[12033](VELOCITY_X,0) = 0.000000; -NODES[12033](VELOCITY_Y,0) = 0.000000; -NODES[12033](VELOCITY_Z,0) = 0.000000; -NODES[12042](VELOCITY_X,0) = 0.000000; -NODES[12042](VELOCITY_Y,0) = 0.000000; -NODES[12042](VELOCITY_Z,0) = 0.000000; -NODES[12052](VELOCITY_X,0) = 0.000000; -NODES[12052](VELOCITY_Y,0) = 0.000000; -NODES[12052](VELOCITY_Z,0) = 0.000000; -NODES[12067](VELOCITY_X,0) = 0.000000; -NODES[12067](VELOCITY_Y,0) = 0.000000; -NODES[12067](VELOCITY_Z,0) = 0.000000; -NODES[12070](VELOCITY_X,0) = 0.000000; -NODES[12070](VELOCITY_Y,0) = 0.000000; -NODES[12070](VELOCITY_Z,0) = 0.000000; -NODES[12072](VELOCITY_X,0) = 0.000000; -NODES[12072](VELOCITY_Y,0) = 0.000000; -NODES[12072](VELOCITY_Z,0) = 0.000000; -NODES[12081](VELOCITY_X,0) = 0.000000; -NODES[12081](VELOCITY_Y,0) = 0.000000; -NODES[12081](VELOCITY_Z,0) = 0.000000; -NODES[12084](VELOCITY_X,0) = 0.000000; -NODES[12084](VELOCITY_Y,0) = 0.000000; -NODES[12084](VELOCITY_Z,0) = 0.000000; -NODES[12086](VELOCITY_X,0) = 0.000000; -NODES[12086](VELOCITY_Y,0) = 0.000000; -NODES[12086](VELOCITY_Z,0) = 0.000000; -NODES[12094](VELOCITY_X,0) = 0.000000; -NODES[12094](VELOCITY_Y,0) = 0.000000; -NODES[12094](VELOCITY_Z,0) = 0.000000; -NODES[12095](VELOCITY_X,0) = 0.000000; -NODES[12095](VELOCITY_Y,0) = 0.000000; -NODES[12095](VELOCITY_Z,0) = 0.000000; -NODES[12096](VELOCITY_X,0) = 0.000000; -NODES[12096](VELOCITY_Y,0) = 0.000000; -NODES[12096](VELOCITY_Z,0) = 0.000000; -NODES[12115](VELOCITY_X,0) = 0.000000; -NODES[12115](VELOCITY_Y,0) = 0.000000; -NODES[12115](VELOCITY_Z,0) = 0.000000; -NODES[12117](VELOCITY_X,0) = 0.000000; -NODES[12117](VELOCITY_Y,0) = 0.000000; -NODES[12117](VELOCITY_Z,0) = 0.000000; -NODES[12134](VELOCITY_X,0) = 0.000000; -NODES[12134](VELOCITY_Y,0) = 0.000000; -NODES[12134](VELOCITY_Z,0) = 0.000000; -NODES[12135](VELOCITY_X,0) = 0.000000; -NODES[12135](VELOCITY_Y,0) = 0.000000; -NODES[12135](VELOCITY_Z,0) = 0.000000; -NODES[12136](VELOCITY_X,0) = 0.000000; -NODES[12136](VELOCITY_Y,0) = 0.000000; -NODES[12136](VELOCITY_Z,0) = 0.000000; -NODES[12137](VELOCITY_X,0) = 0.000000; -NODES[12137](VELOCITY_Y,0) = 0.000000; -NODES[12137](VELOCITY_Z,0) = 0.000000; -NODES[12138](VELOCITY_X,0) = 0.000000; -NODES[12138](VELOCITY_Y,0) = 0.000000; -NODES[12138](VELOCITY_Z,0) = 0.000000; -NODES[12139](VELOCITY_X,0) = 0.000000; -NODES[12139](VELOCITY_Y,0) = 0.000000; -NODES[12139](VELOCITY_Z,0) = 0.000000; -NODES[12143](VELOCITY_X,0) = 0.000000; -NODES[12143](VELOCITY_Y,0) = 0.000000; -NODES[12143](VELOCITY_Z,0) = 0.000000; -NODES[12151](VELOCITY_X,0) = 0.000000; -NODES[12151](VELOCITY_Y,0) = 0.000000; -NODES[12151](VELOCITY_Z,0) = 0.000000; -NODES[12169](VELOCITY_X,0) = 0.000000; -NODES[12169](VELOCITY_Y,0) = 0.000000; -NODES[12169](VELOCITY_Z,0) = 0.000000; -NODES[12170](VELOCITY_X,0) = 0.000000; -NODES[12170](VELOCITY_Y,0) = 0.000000; -NODES[12170](VELOCITY_Z,0) = 0.000000; -NODES[12171](VELOCITY_X,0) = 0.000000; -NODES[12171](VELOCITY_Y,0) = 0.000000; -NODES[12171](VELOCITY_Z,0) = 0.000000; -NODES[12172](VELOCITY_X,0) = 0.000000; -NODES[12172](VELOCITY_Y,0) = 0.000000; -NODES[12172](VELOCITY_Z,0) = 0.000000; -NODES[12183](VELOCITY_X,0) = 0.000000; -NODES[12183](VELOCITY_Y,0) = 0.000000; -NODES[12183](VELOCITY_Z,0) = 0.000000; -NODES[12192](VELOCITY_X,0) = 0.000000; -NODES[12192](VELOCITY_Y,0) = 0.000000; -NODES[12192](VELOCITY_Z,0) = 0.000000; -NODES[12197](VELOCITY_X,0) = 0.000000; -NODES[12197](VELOCITY_Y,0) = 0.000000; -NODES[12197](VELOCITY_Z,0) = 0.000000; -NODES[12211](VELOCITY_X,0) = 0.000000; -NODES[12211](VELOCITY_Y,0) = 0.000000; -NODES[12211](VELOCITY_Z,0) = 0.000000; -NODES[12221](VELOCITY_X,0) = 0.000000; -NODES[12221](VELOCITY_Y,0) = 0.000000; -NODES[12221](VELOCITY_Z,0) = 0.000000; -NODES[12225](VELOCITY_X,0) = 0.000000; -NODES[12225](VELOCITY_Y,0) = 0.000000; -NODES[12225](VELOCITY_Z,0) = 0.000000; -NODES[12230](VELOCITY_X,0) = 0.000000; -NODES[12230](VELOCITY_Y,0) = 0.000000; -NODES[12230](VELOCITY_Z,0) = 0.000000; -NODES[12235](VELOCITY_X,0) = 0.000000; -NODES[12235](VELOCITY_Y,0) = 0.000000; -NODES[12235](VELOCITY_Z,0) = 0.000000; -NODES[12265](VELOCITY_X,0) = 0.000000; -NODES[12265](VELOCITY_Y,0) = 0.000000; -NODES[12265](VELOCITY_Z,0) = 0.000000; -NODES[12266](VELOCITY_X,0) = 0.000000; -NODES[12266](VELOCITY_Y,0) = 0.000000; -NODES[12266](VELOCITY_Z,0) = 0.000000; -NODES[12270](VELOCITY_X,0) = 0.000000; -NODES[12270](VELOCITY_Y,0) = 0.000000; -NODES[12270](VELOCITY_Z,0) = 0.000000; -NODES[12294](VELOCITY_X,0) = 0.000000; -NODES[12294](VELOCITY_Y,0) = 0.000000; -NODES[12294](VELOCITY_Z,0) = 0.000000; -NODES[12309](VELOCITY_X,0) = 0.000000; -NODES[12309](VELOCITY_Y,0) = 0.000000; -NODES[12309](VELOCITY_Z,0) = 0.000000; -NODES[12314](VELOCITY_X,0) = 0.000000; -NODES[12314](VELOCITY_Y,0) = 0.000000; -NODES[12314](VELOCITY_Z,0) = 0.000000; -NODES[12315](VELOCITY_X,0) = 0.000000; -NODES[12315](VELOCITY_Y,0) = 0.000000; -NODES[12315](VELOCITY_Z,0) = 0.000000; -NODES[12316](VELOCITY_X,0) = 0.000000; -NODES[12316](VELOCITY_Y,0) = 0.000000; -NODES[12316](VELOCITY_Z,0) = 0.000000; -NODES[12318](VELOCITY_X,0) = 0.000000; -NODES[12318](VELOCITY_Y,0) = 0.000000; -NODES[12318](VELOCITY_Z,0) = 0.000000; -NODES[12328](VELOCITY_X,0) = 0.000000; -NODES[12328](VELOCITY_Y,0) = 0.000000; -NODES[12328](VELOCITY_Z,0) = 0.000000; -NODES[12329](VELOCITY_X,0) = 0.000000; -NODES[12329](VELOCITY_Y,0) = 0.000000; -NODES[12329](VELOCITY_Z,0) = 0.000000; -NODES[12337](VELOCITY_X,0) = 0.000000; -NODES[12337](VELOCITY_Y,0) = 0.000000; -NODES[12337](VELOCITY_Z,0) = 0.000000; -NODES[12338](VELOCITY_X,0) = 0.000000; -NODES[12338](VELOCITY_Y,0) = 0.000000; -NODES[12338](VELOCITY_Z,0) = 0.000000; -NODES[12339](VELOCITY_X,0) = 0.000000; -NODES[12339](VELOCITY_Y,0) = 0.000000; -NODES[12339](VELOCITY_Z,0) = 0.000000; -NODES[12340](VELOCITY_X,0) = 0.000000; -NODES[12340](VELOCITY_Y,0) = 0.000000; -NODES[12340](VELOCITY_Z,0) = 0.000000; -NODES[12342](VELOCITY_X,0) = 0.000000; -NODES[12342](VELOCITY_Y,0) = 0.000000; -NODES[12342](VELOCITY_Z,0) = 0.000000; -NODES[12349](VELOCITY_X,0) = 0.000000; -NODES[12349](VELOCITY_Y,0) = 0.000000; -NODES[12349](VELOCITY_Z,0) = 0.000000; -NODES[12355](VELOCITY_X,0) = 0.000000; -NODES[12355](VELOCITY_Y,0) = 0.000000; -NODES[12355](VELOCITY_Z,0) = 0.000000; -NODES[12360](VELOCITY_X,0) = 0.000000; -NODES[12360](VELOCITY_Y,0) = 0.000000; -NODES[12360](VELOCITY_Z,0) = 0.000000; -NODES[12361](VELOCITY_X,0) = 0.000000; -NODES[12361](VELOCITY_Y,0) = 0.000000; -NODES[12361](VELOCITY_Z,0) = 0.000000; -NODES[12362](VELOCITY_X,0) = 0.000000; -NODES[12362](VELOCITY_Y,0) = 0.000000; -NODES[12362](VELOCITY_Z,0) = 0.000000; -NODES[12363](VELOCITY_X,0) = 0.000000; -NODES[12363](VELOCITY_Y,0) = 0.000000; -NODES[12363](VELOCITY_Z,0) = 0.000000; -NODES[12371](VELOCITY_X,0) = 0.000000; -NODES[12371](VELOCITY_Y,0) = 0.000000; -NODES[12371](VELOCITY_Z,0) = 0.000000; -NODES[12375](VELOCITY_X,0) = 0.000000; -NODES[12375](VELOCITY_Y,0) = 0.000000; -NODES[12375](VELOCITY_Z,0) = 0.000000; -NODES[12395](VELOCITY_X,0) = 0.000000; -NODES[12395](VELOCITY_Y,0) = 0.000000; -NODES[12395](VELOCITY_Z,0) = 0.000000; -NODES[12396](VELOCITY_X,0) = 0.000000; -NODES[12396](VELOCITY_Y,0) = 0.000000; -NODES[12396](VELOCITY_Z,0) = 0.000000; -NODES[12397](VELOCITY_X,0) = 0.000000; -NODES[12397](VELOCITY_Y,0) = 0.000000; -NODES[12397](VELOCITY_Z,0) = 0.000000; -NODES[12399](VELOCITY_X,0) = 0.000000; -NODES[12399](VELOCITY_Y,0) = 0.000000; -NODES[12399](VELOCITY_Z,0) = 0.000000; -NODES[12400](VELOCITY_X,0) = 0.000000; -NODES[12400](VELOCITY_Y,0) = 0.000000; -NODES[12400](VELOCITY_Z,0) = 0.000000; -NODES[12431](VELOCITY_X,0) = 0.000000; -NODES[12431](VELOCITY_Y,0) = 0.000000; -NODES[12431](VELOCITY_Z,0) = 0.000000; -NODES[12434](VELOCITY_X,0) = 0.000000; -NODES[12434](VELOCITY_Y,0) = 0.000000; -NODES[12434](VELOCITY_Z,0) = 0.000000; -NODES[12439](VELOCITY_X,0) = 0.000000; -NODES[12439](VELOCITY_Y,0) = 0.000000; -NODES[12439](VELOCITY_Z,0) = 0.000000; -NODES[12446](VELOCITY_X,0) = 0.000000; -NODES[12446](VELOCITY_Y,0) = 0.000000; -NODES[12446](VELOCITY_Z,0) = 0.000000; -NODES[12449](VELOCITY_X,0) = 0.000000; -NODES[12449](VELOCITY_Y,0) = 0.000000; -NODES[12449](VELOCITY_Z,0) = 0.000000; -NODES[12451](VELOCITY_X,0) = 0.000000; -NODES[12451](VELOCITY_Y,0) = 0.000000; -NODES[12451](VELOCITY_Z,0) = 0.000000; -NODES[12452](VELOCITY_X,0) = 0.000000; -NODES[12452](VELOCITY_Y,0) = 0.000000; -NODES[12452](VELOCITY_Z,0) = 0.000000; -NODES[12453](VELOCITY_X,0) = 0.000000; -NODES[12453](VELOCITY_Y,0) = 0.000000; -NODES[12453](VELOCITY_Z,0) = 0.000000; -NODES[12456](VELOCITY_X,0) = 0.000000; -NODES[12456](VELOCITY_Y,0) = 0.000000; -NODES[12456](VELOCITY_Z,0) = 0.000000; -NODES[12458](VELOCITY_X,0) = 0.000000; -NODES[12458](VELOCITY_Y,0) = 0.000000; -NODES[12458](VELOCITY_Z,0) = 0.000000; -NODES[12460](VELOCITY_X,0) = 0.000000; -NODES[12460](VELOCITY_Y,0) = 0.000000; -NODES[12460](VELOCITY_Z,0) = 0.000000; -NODES[12461](VELOCITY_X,0) = 0.000000; -NODES[12461](VELOCITY_Y,0) = 0.000000; -NODES[12461](VELOCITY_Z,0) = 0.000000; -NODES[12470](VELOCITY_X,0) = 0.000000; -NODES[12470](VELOCITY_Y,0) = 0.000000; -NODES[12470](VELOCITY_Z,0) = 0.000000; -NODES[12471](VELOCITY_X,0) = 0.000000; -NODES[12471](VELOCITY_Y,0) = 0.000000; -NODES[12471](VELOCITY_Z,0) = 0.000000; -NODES[12487](VELOCITY_X,0) = 0.000000; -NODES[12487](VELOCITY_Y,0) = 0.000000; -NODES[12487](VELOCITY_Z,0) = 0.000000; -NODES[12488](VELOCITY_X,0) = 0.000000; -NODES[12488](VELOCITY_Y,0) = 0.000000; -NODES[12488](VELOCITY_Z,0) = 0.000000; -NODES[12489](VELOCITY_X,0) = 0.000000; -NODES[12489](VELOCITY_Y,0) = 0.000000; -NODES[12489](VELOCITY_Z,0) = 0.000000; -NODES[12498](VELOCITY_X,0) = 0.000000; -NODES[12498](VELOCITY_Y,0) = 0.000000; -NODES[12498](VELOCITY_Z,0) = 0.000000; -NODES[12508](VELOCITY_X,0) = 0.000000; -NODES[12508](VELOCITY_Y,0) = 0.000000; -NODES[12508](VELOCITY_Z,0) = 0.000000; -NODES[12509](VELOCITY_X,0) = 0.000000; -NODES[12509](VELOCITY_Y,0) = 0.000000; -NODES[12509](VELOCITY_Z,0) = 0.000000; -NODES[12523](VELOCITY_X,0) = 0.000000; -NODES[12523](VELOCITY_Y,0) = 0.000000; -NODES[12523](VELOCITY_Z,0) = 0.000000; -NODES[12529](VELOCITY_X,0) = 0.000000; -NODES[12529](VELOCITY_Y,0) = 0.000000; -NODES[12529](VELOCITY_Z,0) = 0.000000; -NODES[12536](VELOCITY_X,0) = 0.000000; -NODES[12536](VELOCITY_Y,0) = 0.000000; -NODES[12536](VELOCITY_Z,0) = 0.000000; -NODES[12548](VELOCITY_X,0) = 0.000000; -NODES[12548](VELOCITY_Y,0) = 0.000000; -NODES[12548](VELOCITY_Z,0) = 0.000000; -NODES[12558](VELOCITY_X,0) = 0.000000; -NODES[12558](VELOCITY_Y,0) = 0.000000; -NODES[12558](VELOCITY_Z,0) = 0.000000; -NODES[12559](VELOCITY_X,0) = 0.000000; -NODES[12559](VELOCITY_Y,0) = 0.000000; -NODES[12559](VELOCITY_Z,0) = 0.000000; -NODES[12564](VELOCITY_X,0) = 0.000000; -NODES[12564](VELOCITY_Y,0) = 0.000000; -NODES[12564](VELOCITY_Z,0) = 0.000000; -NODES[12567](VELOCITY_X,0) = 0.000000; -NODES[12567](VELOCITY_Y,0) = 0.000000; -NODES[12567](VELOCITY_Z,0) = 0.000000; -NODES[12574](VELOCITY_X,0) = 0.000000; -NODES[12574](VELOCITY_Y,0) = 0.000000; -NODES[12574](VELOCITY_Z,0) = 0.000000; -NODES[12596](VELOCITY_X,0) = 0.000000; -NODES[12596](VELOCITY_Y,0) = 0.000000; -NODES[12596](VELOCITY_Z,0) = 0.000000; -NODES[12597](VELOCITY_X,0) = 0.000000; -NODES[12597](VELOCITY_Y,0) = 0.000000; -NODES[12597](VELOCITY_Z,0) = 0.000000; -NODES[12598](VELOCITY_X,0) = 0.000000; -NODES[12598](VELOCITY_Y,0) = 0.000000; -NODES[12598](VELOCITY_Z,0) = 0.000000; -NODES[12599](VELOCITY_X,0) = 0.000000; -NODES[12599](VELOCITY_Y,0) = 0.000000; -NODES[12599](VELOCITY_Z,0) = 0.000000; -NODES[12602](VELOCITY_X,0) = 0.000000; -NODES[12602](VELOCITY_Y,0) = 0.000000; -NODES[12602](VELOCITY_Z,0) = 0.000000; -NODES[12604](VELOCITY_X,0) = 0.000000; -NODES[12604](VELOCITY_Y,0) = 0.000000; -NODES[12604](VELOCITY_Z,0) = 0.000000; -NODES[12618](VELOCITY_X,0) = 0.000000; -NODES[12618](VELOCITY_Y,0) = 0.000000; -NODES[12618](VELOCITY_Z,0) = 0.000000; -NODES[12621](VELOCITY_X,0) = 0.000000; -NODES[12621](VELOCITY_Y,0) = 0.000000; -NODES[12621](VELOCITY_Z,0) = 0.000000; -NODES[12628](VELOCITY_X,0) = 0.000000; -NODES[12628](VELOCITY_Y,0) = 0.000000; -NODES[12628](VELOCITY_Z,0) = 0.000000; -NODES[12630](VELOCITY_X,0) = 0.000000; -NODES[12630](VELOCITY_Y,0) = 0.000000; -NODES[12630](VELOCITY_Z,0) = 0.000000; -NODES[12632](VELOCITY_X,0) = 0.000000; -NODES[12632](VELOCITY_Y,0) = 0.000000; -NODES[12632](VELOCITY_Z,0) = 0.000000; -NODES[12638](VELOCITY_X,0) = 0.000000; -NODES[12638](VELOCITY_Y,0) = 0.000000; -NODES[12638](VELOCITY_Z,0) = 0.000000; -NODES[12653](VELOCITY_X,0) = 0.000000; -NODES[12653](VELOCITY_Y,0) = 0.000000; -NODES[12653](VELOCITY_Z,0) = 0.000000; -NODES[12663](VELOCITY_X,0) = 0.000000; -NODES[12663](VELOCITY_Y,0) = 0.000000; -NODES[12663](VELOCITY_Z,0) = 0.000000; -NODES[12692](VELOCITY_X,0) = 0.000000; -NODES[12692](VELOCITY_Y,0) = 0.000000; -NODES[12692](VELOCITY_Z,0) = 0.000000; -NODES[12693](VELOCITY_X,0) = 0.000000; -NODES[12693](VELOCITY_Y,0) = 0.000000; -NODES[12693](VELOCITY_Z,0) = 0.000000; -NODES[12697](VELOCITY_X,0) = 0.000000; -NODES[12697](VELOCITY_Y,0) = 0.000000; -NODES[12697](VELOCITY_Z,0) = 0.000000; -NODES[12701](VELOCITY_X,0) = 0.000000; -NODES[12701](VELOCITY_Y,0) = 0.000000; -NODES[12701](VELOCITY_Z,0) = 0.000000; -NODES[12710](VELOCITY_X,0) = 0.000000; -NODES[12710](VELOCITY_Y,0) = 0.000000; -NODES[12710](VELOCITY_Z,0) = 0.000000; -NODES[12716](VELOCITY_X,0) = 0.000000; -NODES[12716](VELOCITY_Y,0) = 0.000000; -NODES[12716](VELOCITY_Z,0) = 0.000000; -NODES[12724](VELOCITY_X,0) = 0.000000; -NODES[12724](VELOCITY_Y,0) = 0.000000; -NODES[12724](VELOCITY_Z,0) = 0.000000; -NODES[12725](VELOCITY_X,0) = 0.000000; -NODES[12725](VELOCITY_Y,0) = 0.000000; -NODES[12725](VELOCITY_Z,0) = 0.000000; -NODES[12727](VELOCITY_X,0) = 0.000000; -NODES[12727](VELOCITY_Y,0) = 0.000000; -NODES[12727](VELOCITY_Z,0) = 0.000000; -NODES[12743](VELOCITY_X,0) = 0.000000; -NODES[12743](VELOCITY_Y,0) = 0.000000; -NODES[12743](VELOCITY_Z,0) = 0.000000; -NODES[12744](VELOCITY_X,0) = 0.000000; -NODES[12744](VELOCITY_Y,0) = 0.000000; -NODES[12744](VELOCITY_Z,0) = 0.000000; -NODES[12760](VELOCITY_X,0) = 0.000000; -NODES[12760](VELOCITY_Y,0) = 0.000000; -NODES[12760](VELOCITY_Z,0) = 0.000000; -NODES[12768](VELOCITY_X,0) = 0.000000; -NODES[12768](VELOCITY_Y,0) = 0.000000; -NODES[12768](VELOCITY_Z,0) = 0.000000; -NODES[12774](VELOCITY_X,0) = 0.000000; -NODES[12774](VELOCITY_Y,0) = 0.000000; -NODES[12774](VELOCITY_Z,0) = 0.000000; -NODES[12775](VELOCITY_X,0) = 0.000000; -NODES[12775](VELOCITY_Y,0) = 0.000000; -NODES[12775](VELOCITY_Z,0) = 0.000000; -NODES[12796](VELOCITY_X,0) = 0.000000; -NODES[12796](VELOCITY_Y,0) = 0.000000; -NODES[12796](VELOCITY_Z,0) = 0.000000; -NODES[12798](VELOCITY_X,0) = 0.000000; -NODES[12798](VELOCITY_Y,0) = 0.000000; -NODES[12798](VELOCITY_Z,0) = 0.000000; -NODES[12810](VELOCITY_X,0) = 0.000000; -NODES[12810](VELOCITY_Y,0) = 0.000000; -NODES[12810](VELOCITY_Z,0) = 0.000000; -NODES[12820](VELOCITY_X,0) = 0.000000; -NODES[12820](VELOCITY_Y,0) = 0.000000; -NODES[12820](VELOCITY_Z,0) = 0.000000; -NODES[12821](VELOCITY_X,0) = 0.000000; -NODES[12821](VELOCITY_Y,0) = 0.000000; -NODES[12821](VELOCITY_Z,0) = 0.000000; -NODES[12832](VELOCITY_X,0) = 0.000000; -NODES[12832](VELOCITY_Y,0) = 0.000000; -NODES[12832](VELOCITY_Z,0) = 0.000000; -NODES[12834](VELOCITY_X,0) = 0.000000; -NODES[12834](VELOCITY_Y,0) = 0.000000; -NODES[12834](VELOCITY_Z,0) = 0.000000; -NODES[12842](VELOCITY_X,0) = 0.000000; -NODES[12842](VELOCITY_Y,0) = 0.000000; -NODES[12842](VELOCITY_Z,0) = 0.000000; -NODES[12852](VELOCITY_X,0) = 0.000000; -NODES[12852](VELOCITY_Y,0) = 0.000000; -NODES[12852](VELOCITY_Z,0) = 0.000000; -NODES[12853](VELOCITY_X,0) = 0.000000; -NODES[12853](VELOCITY_Y,0) = 0.000000; -NODES[12853](VELOCITY_Z,0) = 0.000000; -NODES[12854](VELOCITY_X,0) = 0.000000; -NODES[12854](VELOCITY_Y,0) = 0.000000; -NODES[12854](VELOCITY_Z,0) = 0.000000; -NODES[12860](VELOCITY_X,0) = 0.000000; -NODES[12860](VELOCITY_Y,0) = 0.000000; -NODES[12860](VELOCITY_Z,0) = 0.000000; -NODES[12861](VELOCITY_X,0) = 0.000000; -NODES[12861](VELOCITY_Y,0) = 0.000000; -NODES[12861](VELOCITY_Z,0) = 0.000000; -NODES[12862](VELOCITY_X,0) = 0.000000; -NODES[12862](VELOCITY_Y,0) = 0.000000; -NODES[12862](VELOCITY_Z,0) = 0.000000; -NODES[12863](VELOCITY_X,0) = 0.000000; -NODES[12863](VELOCITY_Y,0) = 0.000000; -NODES[12863](VELOCITY_Z,0) = 0.000000; -NODES[12885](VELOCITY_X,0) = 0.000000; -NODES[12885](VELOCITY_Y,0) = 0.000000; -NODES[12885](VELOCITY_Z,0) = 0.000000; -NODES[12912](VELOCITY_X,0) = 0.000000; -NODES[12912](VELOCITY_Y,0) = 0.000000; -NODES[12912](VELOCITY_Z,0) = 0.000000; -NODES[12914](VELOCITY_X,0) = 0.000000; -NODES[12914](VELOCITY_Y,0) = 0.000000; -NODES[12914](VELOCITY_Z,0) = 0.000000; -NODES[12915](VELOCITY_X,0) = 0.000000; -NODES[12915](VELOCITY_Y,0) = 0.000000; -NODES[12915](VELOCITY_Z,0) = 0.000000; -NODES[12925](VELOCITY_X,0) = 0.000000; -NODES[12925](VELOCITY_Y,0) = 0.000000; -NODES[12925](VELOCITY_Z,0) = 0.000000; -NODES[12941](VELOCITY_X,0) = 0.000000; -NODES[12941](VELOCITY_Y,0) = 0.000000; -NODES[12941](VELOCITY_Z,0) = 0.000000; -NODES[12946](VELOCITY_X,0) = 0.000000; -NODES[12946](VELOCITY_Y,0) = 0.000000; -NODES[12946](VELOCITY_Z,0) = 0.000000; -NODES[12951](VELOCITY_X,0) = 0.000000; -NODES[12951](VELOCITY_Y,0) = 0.000000; -NODES[12951](VELOCITY_Z,0) = 0.000000; -NODES[12954](VELOCITY_X,0) = 0.000000; -NODES[12954](VELOCITY_Y,0) = 0.000000; -NODES[12954](VELOCITY_Z,0) = 0.000000; -NODES[12964](VELOCITY_X,0) = 0.000000; -NODES[12964](VELOCITY_Y,0) = 0.000000; -NODES[12964](VELOCITY_Z,0) = 0.000000; -NODES[12966](VELOCITY_X,0) = 0.000000; -NODES[12966](VELOCITY_Y,0) = 0.000000; -NODES[12966](VELOCITY_Z,0) = 0.000000; -NODES[12968](VELOCITY_X,0) = 0.000000; -NODES[12968](VELOCITY_Y,0) = 0.000000; -NODES[12968](VELOCITY_Z,0) = 0.000000; -NODES[12983](VELOCITY_X,0) = 0.000000; -NODES[12983](VELOCITY_Y,0) = 0.000000; -NODES[12983](VELOCITY_Z,0) = 0.000000; -NODES[12991](VELOCITY_X,0) = 0.000000; -NODES[12991](VELOCITY_Y,0) = 0.000000; -NODES[12991](VELOCITY_Z,0) = 0.000000; -NODES[12999](VELOCITY_X,0) = 0.000000; -NODES[12999](VELOCITY_Y,0) = 0.000000; -NODES[12999](VELOCITY_Z,0) = 0.000000; -NODES[13018](VELOCITY_X,0) = 0.000000; -NODES[13018](VELOCITY_Y,0) = 0.000000; -NODES[13018](VELOCITY_Z,0) = 0.000000; -NODES[13029](VELOCITY_X,0) = 0.000000; -NODES[13029](VELOCITY_Y,0) = 0.000000; -NODES[13029](VELOCITY_Z,0) = 0.000000; -NODES[13033](VELOCITY_X,0) = 0.000000; -NODES[13033](VELOCITY_Y,0) = 0.000000; -NODES[13033](VELOCITY_Z,0) = 0.000000; -NODES[13039](VELOCITY_X,0) = 0.000000; -NODES[13039](VELOCITY_Y,0) = 0.000000; -NODES[13039](VELOCITY_Z,0) = 0.000000; -NODES[13042](VELOCITY_X,0) = 0.000000; -NODES[13042](VELOCITY_Y,0) = 0.000000; -NODES[13042](VELOCITY_Z,0) = 0.000000; -NODES[13054](VELOCITY_X,0) = 0.000000; -NODES[13054](VELOCITY_Y,0) = 0.000000; -NODES[13054](VELOCITY_Z,0) = 0.000000; -NODES[13056](VELOCITY_X,0) = 0.000000; -NODES[13056](VELOCITY_Y,0) = 0.000000; -NODES[13056](VELOCITY_Z,0) = 0.000000; -NODES[13065](VELOCITY_X,0) = 0.000000; -NODES[13065](VELOCITY_Y,0) = 0.000000; -NODES[13065](VELOCITY_Z,0) = 0.000000; -NODES[13073](VELOCITY_X,0) = 0.000000; -NODES[13073](VELOCITY_Y,0) = 0.000000; -NODES[13073](VELOCITY_Z,0) = 0.000000; -NODES[13074](VELOCITY_X,0) = 0.000000; -NODES[13074](VELOCITY_Y,0) = 0.000000; -NODES[13074](VELOCITY_Z,0) = 0.000000; -NODES[13086](VELOCITY_X,0) = 0.000000; -NODES[13086](VELOCITY_Y,0) = 0.000000; -NODES[13086](VELOCITY_Z,0) = 0.000000; -NODES[13087](VELOCITY_X,0) = 0.000000; -NODES[13087](VELOCITY_Y,0) = 0.000000; -NODES[13087](VELOCITY_Z,0) = 0.000000; -NODES[13099](VELOCITY_X,0) = 0.000000; -NODES[13099](VELOCITY_Y,0) = 0.000000; -NODES[13099](VELOCITY_Z,0) = 0.000000; -NODES[13104](VELOCITY_X,0) = 0.000000; -NODES[13104](VELOCITY_Y,0) = 0.000000; -NODES[13104](VELOCITY_Z,0) = 0.000000; -NODES[13105](VELOCITY_X,0) = 0.000000; -NODES[13105](VELOCITY_Y,0) = 0.000000; -NODES[13105](VELOCITY_Z,0) = 0.000000; -NODES[13106](VELOCITY_X,0) = 0.000000; -NODES[13106](VELOCITY_Y,0) = 0.000000; -NODES[13106](VELOCITY_Z,0) = 0.000000; -NODES[13107](VELOCITY_X,0) = 0.000000; -NODES[13107](VELOCITY_Y,0) = 0.000000; -NODES[13107](VELOCITY_Z,0) = 0.000000; -NODES[13114](VELOCITY_X,0) = 0.000000; -NODES[13114](VELOCITY_Y,0) = 0.000000; -NODES[13114](VELOCITY_Z,0) = 0.000000; -NODES[13115](VELOCITY_X,0) = 0.000000; -NODES[13115](VELOCITY_Y,0) = 0.000000; -NODES[13115](VELOCITY_Z,0) = 0.000000; -NODES[13124](VELOCITY_X,0) = 0.000000; -NODES[13124](VELOCITY_Y,0) = 0.000000; -NODES[13124](VELOCITY_Z,0) = 0.000000; -NODES[13128](VELOCITY_X,0) = 0.000000; -NODES[13128](VELOCITY_Y,0) = 0.000000; -NODES[13128](VELOCITY_Z,0) = 0.000000; -NODES[13129](VELOCITY_X,0) = 0.000000; -NODES[13129](VELOCITY_Y,0) = 0.000000; -NODES[13129](VELOCITY_Z,0) = 0.000000; -NODES[13130](VELOCITY_X,0) = 0.000000; -NODES[13130](VELOCITY_Y,0) = 0.000000; -NODES[13130](VELOCITY_Z,0) = 0.000000; -NODES[13131](VELOCITY_X,0) = 0.000000; -NODES[13131](VELOCITY_Y,0) = 0.000000; -NODES[13131](VELOCITY_Z,0) = 0.000000; -NODES[13132](VELOCITY_X,0) = 0.000000; -NODES[13132](VELOCITY_Y,0) = 0.000000; -NODES[13132](VELOCITY_Z,0) = 0.000000; -NODES[13133](VELOCITY_X,0) = 0.000000; -NODES[13133](VELOCITY_Y,0) = 0.000000; -NODES[13133](VELOCITY_Z,0) = 0.000000; -NODES[13151](VELOCITY_X,0) = 0.000000; -NODES[13151](VELOCITY_Y,0) = 0.000000; -NODES[13151](VELOCITY_Z,0) = 0.000000; -NODES[13152](VELOCITY_X,0) = 0.000000; -NODES[13152](VELOCITY_Y,0) = 0.000000; -NODES[13152](VELOCITY_Z,0) = 0.000000; -NODES[13155](VELOCITY_X,0) = 0.000000; -NODES[13155](VELOCITY_Y,0) = 0.000000; -NODES[13155](VELOCITY_Z,0) = 0.000000; -NODES[13165](VELOCITY_X,0) = 0.000000; -NODES[13165](VELOCITY_Y,0) = 0.000000; -NODES[13165](VELOCITY_Z,0) = 0.000000; -NODES[13168](VELOCITY_X,0) = 0.000000; -NODES[13168](VELOCITY_Y,0) = 0.000000; -NODES[13168](VELOCITY_Z,0) = 0.000000; -NODES[13169](VELOCITY_X,0) = 0.000000; -NODES[13169](VELOCITY_Y,0) = 0.000000; -NODES[13169](VELOCITY_Z,0) = 0.000000; -NODES[13191](VELOCITY_X,0) = 0.000000; -NODES[13191](VELOCITY_Y,0) = 0.000000; -NODES[13191](VELOCITY_Z,0) = 0.000000; -NODES[13195](VELOCITY_X,0) = 0.000000; -NODES[13195](VELOCITY_Y,0) = 0.000000; -NODES[13195](VELOCITY_Z,0) = 0.000000; -NODES[13201](VELOCITY_X,0) = 0.000000; -NODES[13201](VELOCITY_Y,0) = 0.000000; -NODES[13201](VELOCITY_Z,0) = 0.000000; -NODES[13202](VELOCITY_X,0) = 0.000000; -NODES[13202](VELOCITY_Y,0) = 0.000000; -NODES[13202](VELOCITY_Z,0) = 0.000000; -NODES[13208](VELOCITY_X,0) = 0.000000; -NODES[13208](VELOCITY_Y,0) = 0.000000; -NODES[13208](VELOCITY_Z,0) = 0.000000; -NODES[13209](VELOCITY_X,0) = 0.000000; -NODES[13209](VELOCITY_Y,0) = 0.000000; -NODES[13209](VELOCITY_Z,0) = 0.000000; -NODES[13216](VELOCITY_X,0) = 0.000000; -NODES[13216](VELOCITY_Y,0) = 0.000000; -NODES[13216](VELOCITY_Z,0) = 0.000000; -NODES[13223](VELOCITY_X,0) = 0.000000; -NODES[13223](VELOCITY_Y,0) = 0.000000; -NODES[13223](VELOCITY_Z,0) = 0.000000; -NODES[13235](VELOCITY_X,0) = 0.000000; -NODES[13235](VELOCITY_Y,0) = 0.000000; -NODES[13235](VELOCITY_Z,0) = 0.000000; -NODES[13236](VELOCITY_X,0) = 0.000000; -NODES[13236](VELOCITY_Y,0) = 0.000000; -NODES[13236](VELOCITY_Z,0) = 0.000000; -NODES[13242](VELOCITY_X,0) = 0.000000; -NODES[13242](VELOCITY_Y,0) = 0.000000; -NODES[13242](VELOCITY_Z,0) = 0.000000; -NODES[13255](VELOCITY_X,0) = 0.000000; -NODES[13255](VELOCITY_Y,0) = 0.000000; -NODES[13255](VELOCITY_Z,0) = 0.000000; -NODES[13260](VELOCITY_X,0) = 0.000000; -NODES[13260](VELOCITY_Y,0) = 0.000000; -NODES[13260](VELOCITY_Z,0) = 0.000000; -NODES[13280](VELOCITY_X,0) = 0.000000; -NODES[13280](VELOCITY_Y,0) = 0.000000; -NODES[13280](VELOCITY_Z,0) = 0.000000; -NODES[13283](VELOCITY_X,0) = 0.000000; -NODES[13283](VELOCITY_Y,0) = 0.000000; -NODES[13283](VELOCITY_Z,0) = 0.000000; -NODES[13289](VELOCITY_X,0) = 0.000000; -NODES[13289](VELOCITY_Y,0) = 0.000000; -NODES[13289](VELOCITY_Z,0) = 0.000000; -NODES[13290](VELOCITY_X,0) = 0.000000; -NODES[13290](VELOCITY_Y,0) = 0.000000; -NODES[13290](VELOCITY_Z,0) = 0.000000; -NODES[13299](VELOCITY_X,0) = 0.000000; -NODES[13299](VELOCITY_Y,0) = 0.000000; -NODES[13299](VELOCITY_Z,0) = 0.000000; -NODES[13312](VELOCITY_X,0) = 0.000000; -NODES[13312](VELOCITY_Y,0) = 0.000000; -NODES[13312](VELOCITY_Z,0) = 0.000000; -NODES[13314](VELOCITY_X,0) = 0.000000; -NODES[13314](VELOCITY_Y,0) = 0.000000; -NODES[13314](VELOCITY_Z,0) = 0.000000; -NODES[13326](VELOCITY_X,0) = 0.000000; -NODES[13326](VELOCITY_Y,0) = 0.000000; -NODES[13326](VELOCITY_Z,0) = 0.000000; -NODES[13338](VELOCITY_X,0) = 0.000000; -NODES[13338](VELOCITY_Y,0) = 0.000000; -NODES[13338](VELOCITY_Z,0) = 0.000000; -NODES[13344](VELOCITY_X,0) = 0.000000; -NODES[13344](VELOCITY_Y,0) = 0.000000; -NODES[13344](VELOCITY_Z,0) = 0.000000; -NODES[13347](VELOCITY_X,0) = 0.000000; -NODES[13347](VELOCITY_Y,0) = 0.000000; -NODES[13347](VELOCITY_Z,0) = 0.000000; -NODES[13348](VELOCITY_X,0) = 0.000000; -NODES[13348](VELOCITY_Y,0) = 0.000000; -NODES[13348](VELOCITY_Z,0) = 0.000000; -NODES[13351](VELOCITY_X,0) = 0.000000; -NODES[13351](VELOCITY_Y,0) = 0.000000; -NODES[13351](VELOCITY_Z,0) = 0.000000; -NODES[13360](VELOCITY_X,0) = 0.000000; -NODES[13360](VELOCITY_Y,0) = 0.000000; -NODES[13360](VELOCITY_Z,0) = 0.000000; -NODES[13367](VELOCITY_X,0) = 0.000000; -NODES[13367](VELOCITY_Y,0) = 0.000000; -NODES[13367](VELOCITY_Z,0) = 0.000000; -NODES[13372](VELOCITY_X,0) = 0.000000; -NODES[13372](VELOCITY_Y,0) = 0.000000; -NODES[13372](VELOCITY_Z,0) = 0.000000; -NODES[13378](VELOCITY_X,0) = 0.000000; -NODES[13378](VELOCITY_Y,0) = 0.000000; -NODES[13378](VELOCITY_Z,0) = 0.000000; -NODES[13388](VELOCITY_X,0) = 0.000000; -NODES[13388](VELOCITY_Y,0) = 0.000000; -NODES[13388](VELOCITY_Z,0) = 0.000000; -NODES[13395](VELOCITY_X,0) = 0.000000; -NODES[13395](VELOCITY_Y,0) = 0.000000; -NODES[13395](VELOCITY_Z,0) = 0.000000; -NODES[13417](VELOCITY_X,0) = 0.000000; -NODES[13417](VELOCITY_Y,0) = 0.000000; -NODES[13417](VELOCITY_Z,0) = 0.000000; -NODES[13420](VELOCITY_X,0) = 0.000000; -NODES[13420](VELOCITY_Y,0) = 0.000000; -NODES[13420](VELOCITY_Z,0) = 0.000000; -NODES[13423](VELOCITY_X,0) = 0.000000; -NODES[13423](VELOCITY_Y,0) = 0.000000; -NODES[13423](VELOCITY_Z,0) = 0.000000; -NODES[13424](VELOCITY_X,0) = 0.000000; -NODES[13424](VELOCITY_Y,0) = 0.000000; -NODES[13424](VELOCITY_Z,0) = 0.000000; -NODES[13425](VELOCITY_X,0) = 0.000000; -NODES[13425](VELOCITY_Y,0) = 0.000000; -NODES[13425](VELOCITY_Z,0) = 0.000000; -NODES[13426](VELOCITY_X,0) = 0.000000; -NODES[13426](VELOCITY_Y,0) = 0.000000; -NODES[13426](VELOCITY_Z,0) = 0.000000; -NODES[13436](VELOCITY_X,0) = 0.000000; -NODES[13436](VELOCITY_Y,0) = 0.000000; -NODES[13436](VELOCITY_Z,0) = 0.000000; -NODES[13437](VELOCITY_X,0) = 0.000000; -NODES[13437](VELOCITY_Y,0) = 0.000000; -NODES[13437](VELOCITY_Z,0) = 0.000000; -NODES[13439](VELOCITY_X,0) = 0.000000; -NODES[13439](VELOCITY_Y,0) = 0.000000; -NODES[13439](VELOCITY_Z,0) = 0.000000; -NODES[13447](VELOCITY_X,0) = 0.000000; -NODES[13447](VELOCITY_Y,0) = 0.000000; -NODES[13447](VELOCITY_Z,0) = 0.000000; -NODES[13452](VELOCITY_X,0) = 0.000000; -NODES[13452](VELOCITY_Y,0) = 0.000000; -NODES[13452](VELOCITY_Z,0) = 0.000000; -NODES[13455](VELOCITY_X,0) = 0.000000; -NODES[13455](VELOCITY_Y,0) = 0.000000; -NODES[13455](VELOCITY_Z,0) = 0.000000; -NODES[13466](VELOCITY_X,0) = 0.000000; -NODES[13466](VELOCITY_Y,0) = 0.000000; -NODES[13466](VELOCITY_Z,0) = 0.000000; -NODES[13469](VELOCITY_X,0) = 0.000000; -NODES[13469](VELOCITY_Y,0) = 0.000000; -NODES[13469](VELOCITY_Z,0) = 0.000000; -NODES[13486](VELOCITY_X,0) = 0.000000; -NODES[13486](VELOCITY_Y,0) = 0.000000; -NODES[13486](VELOCITY_Z,0) = 0.000000; -NODES[13493](VELOCITY_X,0) = 0.000000; -NODES[13493](VELOCITY_Y,0) = 0.000000; -NODES[13493](VELOCITY_Z,0) = 0.000000; -NODES[13497](VELOCITY_X,0) = 0.000000; -NODES[13497](VELOCITY_Y,0) = 0.000000; -NODES[13497](VELOCITY_Z,0) = 0.000000; -NODES[13513](VELOCITY_X,0) = 0.000000; -NODES[13513](VELOCITY_Y,0) = 0.000000; -NODES[13513](VELOCITY_Z,0) = 0.000000; -NODES[13524](VELOCITY_X,0) = 0.000000; -NODES[13524](VELOCITY_Y,0) = 0.000000; -NODES[13524](VELOCITY_Z,0) = 0.000000; -NODES[13531](VELOCITY_X,0) = 0.000000; -NODES[13531](VELOCITY_Y,0) = 0.000000; -NODES[13531](VELOCITY_Z,0) = 0.000000; -NODES[13537](VELOCITY_X,0) = 0.000000; -NODES[13537](VELOCITY_Y,0) = 0.000000; -NODES[13537](VELOCITY_Z,0) = 0.000000; -NODES[13538](VELOCITY_X,0) = 0.000000; -NODES[13538](VELOCITY_Y,0) = 0.000000; -NODES[13538](VELOCITY_Z,0) = 0.000000; -NODES[13540](VELOCITY_X,0) = 0.000000; -NODES[13540](VELOCITY_Y,0) = 0.000000; -NODES[13540](VELOCITY_Z,0) = 0.000000; -NODES[13559](VELOCITY_X,0) = 0.000000; -NODES[13559](VELOCITY_Y,0) = 0.000000; -NODES[13559](VELOCITY_Z,0) = 0.000000; -NODES[13562](VELOCITY_X,0) = 0.000000; -NODES[13562](VELOCITY_Y,0) = 0.000000; -NODES[13562](VELOCITY_Z,0) = 0.000000; -NODES[13568](VELOCITY_X,0) = 0.000000; -NODES[13568](VELOCITY_Y,0) = 0.000000; -NODES[13568](VELOCITY_Z,0) = 0.000000; -NODES[13580](VELOCITY_X,0) = 0.000000; -NODES[13580](VELOCITY_Y,0) = 0.000000; -NODES[13580](VELOCITY_Z,0) = 0.000000; -NODES[13595](VELOCITY_X,0) = 0.000000; -NODES[13595](VELOCITY_Y,0) = 0.000000; -NODES[13595](VELOCITY_Z,0) = 0.000000; -NODES[13601](VELOCITY_X,0) = 0.000000; -NODES[13601](VELOCITY_Y,0) = 0.000000; -NODES[13601](VELOCITY_Z,0) = 0.000000; -NODES[13616](VELOCITY_X,0) = 0.000000; -NODES[13616](VELOCITY_Y,0) = 0.000000; -NODES[13616](VELOCITY_Z,0) = 0.000000; -NODES[13618](VELOCITY_X,0) = 0.000000; -NODES[13618](VELOCITY_Y,0) = 0.000000; -NODES[13618](VELOCITY_Z,0) = 0.000000; -NODES[13620](VELOCITY_X,0) = 0.000000; -NODES[13620](VELOCITY_Y,0) = 0.000000; -NODES[13620](VELOCITY_Z,0) = 0.000000; -NODES[13635](VELOCITY_X,0) = 0.000000; -NODES[13635](VELOCITY_Y,0) = 0.000000; -NODES[13635](VELOCITY_Z,0) = 0.000000; -NODES[13638](VELOCITY_X,0) = 0.000000; -NODES[13638](VELOCITY_Y,0) = 0.000000; -NODES[13638](VELOCITY_Z,0) = 0.000000; -NODES[13650](VELOCITY_X,0) = 0.000000; -NODES[13650](VELOCITY_Y,0) = 0.000000; -NODES[13650](VELOCITY_Z,0) = 0.000000; -NODES[13662](VELOCITY_X,0) = 0.000000; -NODES[13662](VELOCITY_Y,0) = 0.000000; -NODES[13662](VELOCITY_Z,0) = 0.000000; -NODES[13678](VELOCITY_X,0) = 0.000000; -NODES[13678](VELOCITY_Y,0) = 0.000000; -NODES[13678](VELOCITY_Z,0) = 0.000000; -NODES[13679](VELOCITY_X,0) = 0.000000; -NODES[13679](VELOCITY_Y,0) = 0.000000; -NODES[13679](VELOCITY_Z,0) = 0.000000; -NODES[13690](VELOCITY_X,0) = 0.000000; -NODES[13690](VELOCITY_Y,0) = 0.000000; -NODES[13690](VELOCITY_Z,0) = 0.000000; -NODES[13692](VELOCITY_X,0) = 0.000000; -NODES[13692](VELOCITY_Y,0) = 0.000000; -NODES[13692](VELOCITY_Z,0) = 0.000000; -NODES[13696](VELOCITY_X,0) = 0.000000; -NODES[13696](VELOCITY_Y,0) = 0.000000; -NODES[13696](VELOCITY_Z,0) = 0.000000; -NODES[13706](VELOCITY_X,0) = 0.000000; -NODES[13706](VELOCITY_Y,0) = 0.000000; -NODES[13706](VELOCITY_Z,0) = 0.000000; -NODES[13712](VELOCITY_X,0) = 0.000000; -NODES[13712](VELOCITY_Y,0) = 0.000000; -NODES[13712](VELOCITY_Z,0) = 0.000000; -NODES[13714](VELOCITY_X,0) = 0.000000; -NODES[13714](VELOCITY_Y,0) = 0.000000; -NODES[13714](VELOCITY_Z,0) = 0.000000; -NODES[13723](VELOCITY_X,0) = 0.000000; -NODES[13723](VELOCITY_Y,0) = 0.000000; -NODES[13723](VELOCITY_Z,0) = 0.000000; -NODES[13724](VELOCITY_X,0) = 0.000000; -NODES[13724](VELOCITY_Y,0) = 0.000000; -NODES[13724](VELOCITY_Z,0) = 0.000000; -NODES[13725](VELOCITY_X,0) = 0.000000; -NODES[13725](VELOCITY_Y,0) = 0.000000; -NODES[13725](VELOCITY_Z,0) = 0.000000; -NODES[13726](VELOCITY_X,0) = 0.000000; -NODES[13726](VELOCITY_Y,0) = 0.000000; -NODES[13726](VELOCITY_Z,0) = 0.000000; -NODES[13727](VELOCITY_X,0) = 0.000000; -NODES[13727](VELOCITY_Y,0) = 0.000000; -NODES[13727](VELOCITY_Z,0) = 0.000000; -NODES[13728](VELOCITY_X,0) = 0.000000; -NODES[13728](VELOCITY_Y,0) = 0.000000; -NODES[13728](VELOCITY_Z,0) = 0.000000; -NODES[13751](VELOCITY_X,0) = 0.000000; -NODES[13751](VELOCITY_Y,0) = 0.000000; -NODES[13751](VELOCITY_Z,0) = 0.000000; -NODES[13774](VELOCITY_X,0) = 0.000000; -NODES[13774](VELOCITY_Y,0) = 0.000000; -NODES[13774](VELOCITY_Z,0) = 0.000000; -NODES[13796](VELOCITY_X,0) = 0.000000; -NODES[13796](VELOCITY_Y,0) = 0.000000; -NODES[13796](VELOCITY_Z,0) = 0.000000; -NODES[13801](VELOCITY_X,0) = 0.000000; -NODES[13801](VELOCITY_Y,0) = 0.000000; -NODES[13801](VELOCITY_Z,0) = 0.000000; -NODES[13802](VELOCITY_X,0) = 0.000000; -NODES[13802](VELOCITY_Y,0) = 0.000000; -NODES[13802](VELOCITY_Z,0) = 0.000000; -NODES[13821](VELOCITY_X,0) = 0.000000; -NODES[13821](VELOCITY_Y,0) = 0.000000; -NODES[13821](VELOCITY_Z,0) = 0.000000; -NODES[13824](VELOCITY_X,0) = 0.000000; -NODES[13824](VELOCITY_Y,0) = 0.000000; -NODES[13824](VELOCITY_Z,0) = 0.000000; -NODES[13831](VELOCITY_X,0) = 0.000000; -NODES[13831](VELOCITY_Y,0) = 0.000000; -NODES[13831](VELOCITY_Z,0) = 0.000000; -NODES[13833](VELOCITY_X,0) = 0.000000; -NODES[13833](VELOCITY_Y,0) = 0.000000; -NODES[13833](VELOCITY_Z,0) = 0.000000; -NODES[13834](VELOCITY_X,0) = 0.000000; -NODES[13834](VELOCITY_Y,0) = 0.000000; -NODES[13834](VELOCITY_Z,0) = 0.000000; -NODES[13838](VELOCITY_X,0) = 0.000000; -NODES[13838](VELOCITY_Y,0) = 0.000000; -NODES[13838](VELOCITY_Z,0) = 0.000000; -NODES[13843](VELOCITY_X,0) = 0.000000; -NODES[13843](VELOCITY_Y,0) = 0.000000; -NODES[13843](VELOCITY_Z,0) = 0.000000; -NODES[13852](VELOCITY_X,0) = 0.000000; -NODES[13852](VELOCITY_Y,0) = 0.000000; -NODES[13852](VELOCITY_Z,0) = 0.000000; -NODES[13862](VELOCITY_X,0) = 0.000000; -NODES[13862](VELOCITY_Y,0) = 0.000000; -NODES[13862](VELOCITY_Z,0) = 0.000000; -NODES[13865](VELOCITY_X,0) = 0.000000; -NODES[13865](VELOCITY_Y,0) = 0.000000; -NODES[13865](VELOCITY_Z,0) = 0.000000; -NODES[13867](VELOCITY_X,0) = 0.000000; -NODES[13867](VELOCITY_Y,0) = 0.000000; -NODES[13867](VELOCITY_Z,0) = 0.000000; -NODES[13889](VELOCITY_X,0) = 0.000000; -NODES[13889](VELOCITY_Y,0) = 0.000000; -NODES[13889](VELOCITY_Z,0) = 0.000000; -NODES[13890](VELOCITY_X,0) = 0.000000; -NODES[13890](VELOCITY_Y,0) = 0.000000; -NODES[13890](VELOCITY_Z,0) = 0.000000; -NODES[13893](VELOCITY_X,0) = 0.000000; -NODES[13893](VELOCITY_Y,0) = 0.000000; -NODES[13893](VELOCITY_Z,0) = 0.000000; -NODES[13899](VELOCITY_X,0) = 0.000000; -NODES[13899](VELOCITY_Y,0) = 0.000000; -NODES[13899](VELOCITY_Z,0) = 0.000000; -NODES[13904](VELOCITY_X,0) = 0.000000; -NODES[13904](VELOCITY_Y,0) = 0.000000; -NODES[13904](VELOCITY_Z,0) = 0.000000; -NODES[13905](VELOCITY_X,0) = 0.000000; -NODES[13905](VELOCITY_Y,0) = 0.000000; -NODES[13905](VELOCITY_Z,0) = 0.000000; -NODES[13908](VELOCITY_X,0) = 0.000000; -NODES[13908](VELOCITY_Y,0) = 0.000000; -NODES[13908](VELOCITY_Z,0) = 0.000000; -NODES[13909](VELOCITY_X,0) = 0.000000; -NODES[13909](VELOCITY_Y,0) = 0.000000; -NODES[13909](VELOCITY_Z,0) = 0.000000; -NODES[13910](VELOCITY_X,0) = 0.000000; -NODES[13910](VELOCITY_Y,0) = 0.000000; -NODES[13910](VELOCITY_Z,0) = 0.000000; -NODES[13916](VELOCITY_X,0) = 0.000000; -NODES[13916](VELOCITY_Y,0) = 0.000000; -NODES[13916](VELOCITY_Z,0) = 0.000000; -NODES[13918](VELOCITY_X,0) = 0.000000; -NODES[13918](VELOCITY_Y,0) = 0.000000; -NODES[13918](VELOCITY_Z,0) = 0.000000; -NODES[13923](VELOCITY_X,0) = 0.000000; -NODES[13923](VELOCITY_Y,0) = 0.000000; -NODES[13923](VELOCITY_Z,0) = 0.000000; -NODES[13931](VELOCITY_X,0) = 0.000000; -NODES[13931](VELOCITY_Y,0) = 0.000000; -NODES[13931](VELOCITY_Z,0) = 0.000000; -NODES[13932](VELOCITY_X,0) = 0.000000; -NODES[13932](VELOCITY_Y,0) = 0.000000; -NODES[13932](VELOCITY_Z,0) = 0.000000; -NODES[13935](VELOCITY_X,0) = 0.000000; -NODES[13935](VELOCITY_Y,0) = 0.000000; -NODES[13935](VELOCITY_Z,0) = 0.000000; -NODES[13939](VELOCITY_X,0) = 0.000000; -NODES[13939](VELOCITY_Y,0) = 0.000000; -NODES[13939](VELOCITY_Z,0) = 0.000000; -NODES[13945](VELOCITY_X,0) = 0.000000; -NODES[13945](VELOCITY_Y,0) = 0.000000; -NODES[13945](VELOCITY_Z,0) = 0.000000; -NODES[13950](VELOCITY_X,0) = 0.000000; -NODES[13950](VELOCITY_Y,0) = 0.000000; -NODES[13950](VELOCITY_Z,0) = 0.000000; -NODES[13956](VELOCITY_X,0) = 0.000000; -NODES[13956](VELOCITY_Y,0) = 0.000000; -NODES[13956](VELOCITY_Z,0) = 0.000000; -NODES[13977](VELOCITY_X,0) = 0.000000; -NODES[13977](VELOCITY_Y,0) = 0.000000; -NODES[13977](VELOCITY_Z,0) = 0.000000; -NODES[13979](VELOCITY_X,0) = 0.000000; -NODES[13979](VELOCITY_Y,0) = 0.000000; -NODES[13979](VELOCITY_Z,0) = 0.000000; -NODES[13980](VELOCITY_X,0) = 0.000000; -NODES[13980](VELOCITY_Y,0) = 0.000000; -NODES[13980](VELOCITY_Z,0) = 0.000000; -NODES[13987](VELOCITY_X,0) = 0.000000; -NODES[13987](VELOCITY_Y,0) = 0.000000; -NODES[13987](VELOCITY_Z,0) = 0.000000; -NODES[13991](VELOCITY_X,0) = 0.000000; -NODES[13991](VELOCITY_Y,0) = 0.000000; -NODES[13991](VELOCITY_Z,0) = 0.000000; -NODES[14006](VELOCITY_X,0) = 0.000000; -NODES[14006](VELOCITY_Y,0) = 0.000000; -NODES[14006](VELOCITY_Z,0) = 0.000000; -NODES[14007](VELOCITY_X,0) = 0.000000; -NODES[14007](VELOCITY_Y,0) = 0.000000; -NODES[14007](VELOCITY_Z,0) = 0.000000; -NODES[14016](VELOCITY_X,0) = 0.000000; -NODES[14016](VELOCITY_Y,0) = 0.000000; -NODES[14016](VELOCITY_Z,0) = 0.000000; -NODES[14017](VELOCITY_X,0) = 0.000000; -NODES[14017](VELOCITY_Y,0) = 0.000000; -NODES[14017](VELOCITY_Z,0) = 0.000000; -NODES[14034](VELOCITY_X,0) = 0.000000; -NODES[14034](VELOCITY_Y,0) = 0.000000; -NODES[14034](VELOCITY_Z,0) = 0.000000; -NODES[14035](VELOCITY_X,0) = 0.000000; -NODES[14035](VELOCITY_Y,0) = 0.000000; -NODES[14035](VELOCITY_Z,0) = 0.000000; -NODES[14036](VELOCITY_X,0) = 0.000000; -NODES[14036](VELOCITY_Y,0) = 0.000000; -NODES[14036](VELOCITY_Z,0) = 0.000000; -NODES[14037](VELOCITY_X,0) = 0.000000; -NODES[14037](VELOCITY_Y,0) = 0.000000; -NODES[14037](VELOCITY_Z,0) = 0.000000; -NODES[14038](VELOCITY_X,0) = 0.000000; -NODES[14038](VELOCITY_Y,0) = 0.000000; -NODES[14038](VELOCITY_Z,0) = 0.000000; -NODES[14052](VELOCITY_X,0) = 0.000000; -NODES[14052](VELOCITY_Y,0) = 0.000000; -NODES[14052](VELOCITY_Z,0) = 0.000000; -NODES[14054](VELOCITY_X,0) = 0.000000; -NODES[14054](VELOCITY_Y,0) = 0.000000; -NODES[14054](VELOCITY_Z,0) = 0.000000; -NODES[14056](VELOCITY_X,0) = 0.000000; -NODES[14056](VELOCITY_Y,0) = 0.000000; -NODES[14056](VELOCITY_Z,0) = 0.000000; -NODES[14064](VELOCITY_X,0) = 0.000000; -NODES[14064](VELOCITY_Y,0) = 0.000000; -NODES[14064](VELOCITY_Z,0) = 0.000000; -NODES[14073](VELOCITY_X,0) = 0.000000; -NODES[14073](VELOCITY_Y,0) = 0.000000; -NODES[14073](VELOCITY_Z,0) = 0.000000; -NODES[14074](VELOCITY_X,0) = 0.000000; -NODES[14074](VELOCITY_Y,0) = 0.000000; -NODES[14074](VELOCITY_Z,0) = 0.000000; -NODES[14076](VELOCITY_X,0) = 0.000000; -NODES[14076](VELOCITY_Y,0) = 0.000000; -NODES[14076](VELOCITY_Z,0) = 0.000000; -NODES[14091](VELOCITY_X,0) = 0.000000; -NODES[14091](VELOCITY_Y,0) = 0.000000; -NODES[14091](VELOCITY_Z,0) = 0.000000; -NODES[14113](VELOCITY_X,0) = 0.000000; -NODES[14113](VELOCITY_Y,0) = 0.000000; -NODES[14113](VELOCITY_Z,0) = 0.000000; -NODES[14116](VELOCITY_X,0) = 0.000000; -NODES[14116](VELOCITY_Y,0) = 0.000000; -NODES[14116](VELOCITY_Z,0) = 0.000000; -NODES[14121](VELOCITY_X,0) = 0.000000; -NODES[14121](VELOCITY_Y,0) = 0.000000; -NODES[14121](VELOCITY_Z,0) = 0.000000; -NODES[14124](VELOCITY_X,0) = 0.000000; -NODES[14124](VELOCITY_Y,0) = 0.000000; -NODES[14124](VELOCITY_Z,0) = 0.000000; -NODES[14146](VELOCITY_X,0) = 0.000000; -NODES[14146](VELOCITY_Y,0) = 0.000000; -NODES[14146](VELOCITY_Z,0) = 0.000000; -NODES[14167](VELOCITY_X,0) = 0.000000; -NODES[14167](VELOCITY_Y,0) = 0.000000; -NODES[14167](VELOCITY_Z,0) = 0.000000; -NODES[14175](VELOCITY_X,0) = 0.000000; -NODES[14175](VELOCITY_Y,0) = 0.000000; -NODES[14175](VELOCITY_Z,0) = 0.000000; -NODES[14179](VELOCITY_X,0) = 0.000000; -NODES[14179](VELOCITY_Y,0) = 0.000000; -NODES[14179](VELOCITY_Z,0) = 0.000000; -NODES[14189](VELOCITY_X,0) = 0.000000; -NODES[14189](VELOCITY_Y,0) = 0.000000; -NODES[14189](VELOCITY_Z,0) = 0.000000; -NODES[14197](VELOCITY_X,0) = 0.000000; -NODES[14197](VELOCITY_Y,0) = 0.000000; -NODES[14197](VELOCITY_Z,0) = 0.000000; -NODES[14203](VELOCITY_X,0) = 0.000000; -NODES[14203](VELOCITY_Y,0) = 0.000000; -NODES[14203](VELOCITY_Z,0) = 0.000000; -NODES[14212](VELOCITY_X,0) = 0.000000; -NODES[14212](VELOCITY_Y,0) = 0.000000; -NODES[14212](VELOCITY_Z,0) = 0.000000; -NODES[14225](VELOCITY_X,0) = 0.000000; -NODES[14225](VELOCITY_Y,0) = 0.000000; -NODES[14225](VELOCITY_Z,0) = 0.000000; -NODES[14228](VELOCITY_X,0) = 0.000000; -NODES[14228](VELOCITY_Y,0) = 0.000000; -NODES[14228](VELOCITY_Z,0) = 0.000000; -NODES[14232](VELOCITY_X,0) = 0.000000; -NODES[14232](VELOCITY_Y,0) = 0.000000; -NODES[14232](VELOCITY_Z,0) = 0.000000; -NODES[14235](VELOCITY_X,0) = 0.000000; -NODES[14235](VELOCITY_Y,0) = 0.000000; -NODES[14235](VELOCITY_Z,0) = 0.000000; -NODES[14236](VELOCITY_X,0) = 0.000000; -NODES[14236](VELOCITY_Y,0) = 0.000000; -NODES[14236](VELOCITY_Z,0) = 0.000000; -NODES[14239](VELOCITY_X,0) = 0.000000; -NODES[14239](VELOCITY_Y,0) = 0.000000; -NODES[14239](VELOCITY_Z,0) = 0.000000; -NODES[14242](VELOCITY_X,0) = 0.000000; -NODES[14242](VELOCITY_Y,0) = 0.000000; -NODES[14242](VELOCITY_Z,0) = 0.000000; -NODES[14281](VELOCITY_X,0) = 0.000000; -NODES[14281](VELOCITY_Y,0) = 0.000000; -NODES[14281](VELOCITY_Z,0) = 0.000000; -NODES[14282](VELOCITY_X,0) = 0.000000; -NODES[14282](VELOCITY_Y,0) = 0.000000; -NODES[14282](VELOCITY_Z,0) = 0.000000; -NODES[14284](VELOCITY_X,0) = 0.000000; -NODES[14284](VELOCITY_Y,0) = 0.000000; -NODES[14284](VELOCITY_Z,0) = 0.000000; -NODES[14288](VELOCITY_X,0) = 0.000000; -NODES[14288](VELOCITY_Y,0) = 0.000000; -NODES[14288](VELOCITY_Z,0) = 0.000000; -NODES[14295](VELOCITY_X,0) = 0.000000; -NODES[14295](VELOCITY_Y,0) = 0.000000; -NODES[14295](VELOCITY_Z,0) = 0.000000; -NODES[14303](VELOCITY_X,0) = 0.000000; -NODES[14303](VELOCITY_Y,0) = 0.000000; -NODES[14303](VELOCITY_Z,0) = 0.000000; -NODES[14306](VELOCITY_X,0) = 0.000000; -NODES[14306](VELOCITY_Y,0) = 0.000000; -NODES[14306](VELOCITY_Z,0) = 0.000000; -NODES[14307](VELOCITY_X,0) = 0.000000; -NODES[14307](VELOCITY_Y,0) = 0.000000; -NODES[14307](VELOCITY_Z,0) = 0.000000; -NODES[14308](VELOCITY_X,0) = 0.000000; -NODES[14308](VELOCITY_Y,0) = 0.000000; -NODES[14308](VELOCITY_Z,0) = 0.000000; -NODES[14314](VELOCITY_X,0) = 0.000000; -NODES[14314](VELOCITY_Y,0) = 0.000000; -NODES[14314](VELOCITY_Z,0) = 0.000000; -NODES[14317](VELOCITY_X,0) = 0.000000; -NODES[14317](VELOCITY_Y,0) = 0.000000; -NODES[14317](VELOCITY_Z,0) = 0.000000; -NODES[14323](VELOCITY_X,0) = 0.000000; -NODES[14323](VELOCITY_Y,0) = 0.000000; -NODES[14323](VELOCITY_Z,0) = 0.000000; -NODES[14326](VELOCITY_X,0) = 0.000000; -NODES[14326](VELOCITY_Y,0) = 0.000000; -NODES[14326](VELOCITY_Z,0) = 0.000000; -NODES[14328](VELOCITY_X,0) = 0.000000; -NODES[14328](VELOCITY_Y,0) = 0.000000; -NODES[14328](VELOCITY_Z,0) = 0.000000; -NODES[14344](VELOCITY_X,0) = 0.000000; -NODES[14344](VELOCITY_Y,0) = 0.000000; -NODES[14344](VELOCITY_Z,0) = 0.000000; -NODES[14345](VELOCITY_X,0) = 0.000000; -NODES[14345](VELOCITY_Y,0) = 0.000000; -NODES[14345](VELOCITY_Z,0) = 0.000000; -NODES[14346](VELOCITY_X,0) = 0.000000; -NODES[14346](VELOCITY_Y,0) = 0.000000; -NODES[14346](VELOCITY_Z,0) = 0.000000; -NODES[14347](VELOCITY_X,0) = 0.000000; -NODES[14347](VELOCITY_Y,0) = 0.000000; -NODES[14347](VELOCITY_Z,0) = 0.000000; -NODES[14376](VELOCITY_X,0) = 0.000000; -NODES[14376](VELOCITY_Y,0) = 0.000000; -NODES[14376](VELOCITY_Z,0) = 0.000000; -NODES[14378](VELOCITY_X,0) = 0.000000; -NODES[14378](VELOCITY_Y,0) = 0.000000; -NODES[14378](VELOCITY_Z,0) = 0.000000; -NODES[14385](VELOCITY_X,0) = 0.000000; -NODES[14385](VELOCITY_Y,0) = 0.000000; -NODES[14385](VELOCITY_Z,0) = 0.000000; -NODES[14386](VELOCITY_X,0) = 0.000000; -NODES[14386](VELOCITY_Y,0) = 0.000000; -NODES[14386](VELOCITY_Z,0) = 0.000000; -NODES[14399](VELOCITY_X,0) = 0.000000; -NODES[14399](VELOCITY_Y,0) = 0.000000; -NODES[14399](VELOCITY_Z,0) = 0.000000; -NODES[14402](VELOCITY_X,0) = 0.000000; -NODES[14402](VELOCITY_Y,0) = 0.000000; -NODES[14402](VELOCITY_Z,0) = 0.000000; -NODES[14404](VELOCITY_X,0) = 0.000000; -NODES[14404](VELOCITY_Y,0) = 0.000000; -NODES[14404](VELOCITY_Z,0) = 0.000000; -NODES[14405](VELOCITY_X,0) = 0.000000; -NODES[14405](VELOCITY_Y,0) = 0.000000; -NODES[14405](VELOCITY_Z,0) = 0.000000; -NODES[14410](VELOCITY_X,0) = 0.000000; -NODES[14410](VELOCITY_Y,0) = 0.000000; -NODES[14410](VELOCITY_Z,0) = 0.000000; -NODES[14418](VELOCITY_X,0) = 0.000000; -NODES[14418](VELOCITY_Y,0) = 0.000000; -NODES[14418](VELOCITY_Z,0) = 0.000000; -NODES[14431](VELOCITY_X,0) = 0.000000; -NODES[14431](VELOCITY_Y,0) = 0.000000; -NODES[14431](VELOCITY_Z,0) = 0.000000; -NODES[14442](VELOCITY_X,0) = 0.000000; -NODES[14442](VELOCITY_Y,0) = 0.000000; -NODES[14442](VELOCITY_Z,0) = 0.000000; -NODES[14449](VELOCITY_X,0) = 0.000000; -NODES[14449](VELOCITY_Y,0) = 0.000000; -NODES[14449](VELOCITY_Z,0) = 0.000000; -NODES[14450](VELOCITY_X,0) = 0.000000; -NODES[14450](VELOCITY_Y,0) = 0.000000; -NODES[14450](VELOCITY_Z,0) = 0.000000; -NODES[14459](VELOCITY_X,0) = 0.000000; -NODES[14459](VELOCITY_Y,0) = 0.000000; -NODES[14459](VELOCITY_Z,0) = 0.000000; -NODES[14473](VELOCITY_X,0) = 0.000000; -NODES[14473](VELOCITY_Y,0) = 0.000000; -NODES[14473](VELOCITY_Z,0) = 0.000000; -NODES[14519](VELOCITY_X,0) = 0.000000; -NODES[14519](VELOCITY_Y,0) = 0.000000; -NODES[14519](VELOCITY_Z,0) = 0.000000; -NODES[14522](VELOCITY_X,0) = 0.000000; -NODES[14522](VELOCITY_Y,0) = 0.000000; -NODES[14522](VELOCITY_Z,0) = 0.000000; -NODES[14524](VELOCITY_X,0) = 0.000000; -NODES[14524](VELOCITY_Y,0) = 0.000000; -NODES[14524](VELOCITY_Z,0) = 0.000000; -NODES[14532](VELOCITY_X,0) = 0.000000; -NODES[14532](VELOCITY_Y,0) = 0.000000; -NODES[14532](VELOCITY_Z,0) = 0.000000; -NODES[14536](VELOCITY_X,0) = 0.000000; -NODES[14536](VELOCITY_Y,0) = 0.000000; -NODES[14536](VELOCITY_Z,0) = 0.000000; -NODES[14542](VELOCITY_X,0) = 0.000000; -NODES[14542](VELOCITY_Y,0) = 0.000000; -NODES[14542](VELOCITY_Z,0) = 0.000000; -NODES[14551](VELOCITY_X,0) = 0.000000; -NODES[14551](VELOCITY_Y,0) = 0.000000; -NODES[14551](VELOCITY_Z,0) = 0.000000; -NODES[14552](VELOCITY_X,0) = 0.000000; -NODES[14552](VELOCITY_Y,0) = 0.000000; -NODES[14552](VELOCITY_Z,0) = 0.000000; -NODES[14556](VELOCITY_X,0) = 0.000000; -NODES[14556](VELOCITY_Y,0) = 0.000000; -NODES[14556](VELOCITY_Z,0) = 0.000000; -NODES[14558](VELOCITY_X,0) = 0.000000; -NODES[14558](VELOCITY_Y,0) = 0.000000; -NODES[14558](VELOCITY_Z,0) = 0.000000; -NODES[14563](VELOCITY_X,0) = 0.000000; -NODES[14563](VELOCITY_Y,0) = 0.000000; -NODES[14563](VELOCITY_Z,0) = 0.000000; -NODES[14590](VELOCITY_X,0) = 0.000000; -NODES[14590](VELOCITY_Y,0) = 0.000000; -NODES[14590](VELOCITY_Z,0) = 0.000000; -NODES[14605](VELOCITY_X,0) = 0.000000; -NODES[14605](VELOCITY_Y,0) = 0.000000; -NODES[14605](VELOCITY_Z,0) = 0.000000; -NODES[14609](VELOCITY_X,0) = 0.000000; -NODES[14609](VELOCITY_Y,0) = 0.000000; -NODES[14609](VELOCITY_Z,0) = 0.000000; -NODES[14619](VELOCITY_X,0) = 0.000000; -NODES[14619](VELOCITY_Y,0) = 0.000000; -NODES[14619](VELOCITY_Z,0) = 0.000000; -NODES[14620](VELOCITY_X,0) = 0.000000; -NODES[14620](VELOCITY_Y,0) = 0.000000; -NODES[14620](VELOCITY_Z,0) = 0.000000; -NODES[14644](VELOCITY_X,0) = 0.000000; -NODES[14644](VELOCITY_Y,0) = 0.000000; -NODES[14644](VELOCITY_Z,0) = 0.000000; -NODES[14646](VELOCITY_X,0) = 0.000000; -NODES[14646](VELOCITY_Y,0) = 0.000000; -NODES[14646](VELOCITY_Z,0) = 0.000000; -NODES[14660](VELOCITY_X,0) = 0.000000; -NODES[14660](VELOCITY_Y,0) = 0.000000; -NODES[14660](VELOCITY_Z,0) = 0.000000; -NODES[14662](VELOCITY_X,0) = 0.000000; -NODES[14662](VELOCITY_Y,0) = 0.000000; -NODES[14662](VELOCITY_Z,0) = 0.000000; -NODES[14663](VELOCITY_X,0) = 0.000000; -NODES[14663](VELOCITY_Y,0) = 0.000000; -NODES[14663](VELOCITY_Z,0) = 0.000000; -NODES[14668](VELOCITY_X,0) = 0.000000; -NODES[14668](VELOCITY_Y,0) = 0.000000; -NODES[14668](VELOCITY_Z,0) = 0.000000; -NODES[14669](VELOCITY_X,0) = 0.000000; -NODES[14669](VELOCITY_Y,0) = 0.000000; -NODES[14669](VELOCITY_Z,0) = 0.000000; -NODES[14680](VELOCITY_X,0) = 0.000000; -NODES[14680](VELOCITY_Y,0) = 0.000000; -NODES[14680](VELOCITY_Z,0) = 0.000000; -NODES[14681](VELOCITY_X,0) = 0.000000; -NODES[14681](VELOCITY_Y,0) = 0.000000; -NODES[14681](VELOCITY_Z,0) = 0.000000; -NODES[14682](VELOCITY_X,0) = 0.000000; -NODES[14682](VELOCITY_Y,0) = 0.000000; -NODES[14682](VELOCITY_Z,0) = 0.000000; -NODES[14683](VELOCITY_X,0) = 0.000000; -NODES[14683](VELOCITY_Y,0) = 0.000000; -NODES[14683](VELOCITY_Z,0) = 0.000000; -NODES[14684](VELOCITY_X,0) = 0.000000; -NODES[14684](VELOCITY_Y,0) = 0.000000; -NODES[14684](VELOCITY_Z,0) = 0.000000; -NODES[14689](VELOCITY_X,0) = 0.000000; -NODES[14689](VELOCITY_Y,0) = 0.000000; -NODES[14689](VELOCITY_Z,0) = 0.000000; -NODES[14690](VELOCITY_X,0) = 0.000000; -NODES[14690](VELOCITY_Y,0) = 0.000000; -NODES[14690](VELOCITY_Z,0) = 0.000000; -NODES[14705](VELOCITY_X,0) = 0.000000; -NODES[14705](VELOCITY_Y,0) = 0.000000; -NODES[14705](VELOCITY_Z,0) = 0.000000; -NODES[14719](VELOCITY_X,0) = 0.000000; -NODES[14719](VELOCITY_Y,0) = 0.000000; -NODES[14719](VELOCITY_Z,0) = 0.000000; -NODES[14723](VELOCITY_X,0) = 0.000000; -NODES[14723](VELOCITY_Y,0) = 0.000000; -NODES[14723](VELOCITY_Z,0) = 0.000000; -NODES[14726](VELOCITY_X,0) = 0.000000; -NODES[14726](VELOCITY_Y,0) = 0.000000; -NODES[14726](VELOCITY_Z,0) = 0.000000; -NODES[14731](VELOCITY_X,0) = 0.000000; -NODES[14731](VELOCITY_Y,0) = 0.000000; -NODES[14731](VELOCITY_Z,0) = 0.000000; -NODES[14732](VELOCITY_X,0) = 0.000000; -NODES[14732](VELOCITY_Y,0) = 0.000000; -NODES[14732](VELOCITY_Z,0) = 0.000000; -NODES[14734](VELOCITY_X,0) = 0.000000; -NODES[14734](VELOCITY_Y,0) = 0.000000; -NODES[14734](VELOCITY_Z,0) = 0.000000; -NODES[14736](VELOCITY_X,0) = 0.000000; -NODES[14736](VELOCITY_Y,0) = 0.000000; -NODES[14736](VELOCITY_Z,0) = 0.000000; -NODES[14737](VELOCITY_X,0) = 0.000000; -NODES[14737](VELOCITY_Y,0) = 0.000000; -NODES[14737](VELOCITY_Z,0) = 0.000000; -NODES[14745](VELOCITY_X,0) = 0.000000; -NODES[14745](VELOCITY_Y,0) = 0.000000; -NODES[14745](VELOCITY_Z,0) = 0.000000; -NODES[14750](VELOCITY_X,0) = 0.000000; -NODES[14750](VELOCITY_Y,0) = 0.000000; -NODES[14750](VELOCITY_Z,0) = 0.000000; -NODES[14763](VELOCITY_X,0) = 0.000000; -NODES[14763](VELOCITY_Y,0) = 0.000000; -NODES[14763](VELOCITY_Z,0) = 0.000000; -NODES[14765](VELOCITY_X,0) = 0.000000; -NODES[14765](VELOCITY_Y,0) = 0.000000; -NODES[14765](VELOCITY_Z,0) = 0.000000; -NODES[14766](VELOCITY_X,0) = 0.000000; -NODES[14766](VELOCITY_Y,0) = 0.000000; -NODES[14766](VELOCITY_Z,0) = 0.000000; -NODES[14768](VELOCITY_X,0) = 0.000000; -NODES[14768](VELOCITY_Y,0) = 0.000000; -NODES[14768](VELOCITY_Z,0) = 0.000000; -NODES[14776](VELOCITY_X,0) = 0.000000; -NODES[14776](VELOCITY_Y,0) = 0.000000; -NODES[14776](VELOCITY_Z,0) = 0.000000; -NODES[14782](VELOCITY_X,0) = 0.000000; -NODES[14782](VELOCITY_Y,0) = 0.000000; -NODES[14782](VELOCITY_Z,0) = 0.000000; -NODES[14792](VELOCITY_X,0) = 0.000000; -NODES[14792](VELOCITY_Y,0) = 0.000000; -NODES[14792](VELOCITY_Z,0) = 0.000000; -NODES[14794](VELOCITY_X,0) = 0.000000; -NODES[14794](VELOCITY_Y,0) = 0.000000; -NODES[14794](VELOCITY_Z,0) = 0.000000; -NODES[14797](VELOCITY_X,0) = 0.000000; -NODES[14797](VELOCITY_Y,0) = 0.000000; -NODES[14797](VELOCITY_Z,0) = 0.000000; -NODES[14800](VELOCITY_X,0) = 0.000000; -NODES[14800](VELOCITY_Y,0) = 0.000000; -NODES[14800](VELOCITY_Z,0) = 0.000000; -NODES[14813](VELOCITY_X,0) = 0.000000; -NODES[14813](VELOCITY_Y,0) = 0.000000; -NODES[14813](VELOCITY_Z,0) = 0.000000; -NODES[14817](VELOCITY_X,0) = 0.000000; -NODES[14817](VELOCITY_Y,0) = 0.000000; -NODES[14817](VELOCITY_Z,0) = 0.000000; -NODES[14823](VELOCITY_X,0) = 0.000000; -NODES[14823](VELOCITY_Y,0) = 0.000000; -NODES[14823](VELOCITY_Z,0) = 0.000000; -NODES[14833](VELOCITY_X,0) = 0.000000; -NODES[14833](VELOCITY_Y,0) = 0.000000; -NODES[14833](VELOCITY_Z,0) = 0.000000; -NODES[14838](VELOCITY_X,0) = 0.000000; -NODES[14838](VELOCITY_Y,0) = 0.000000; -NODES[14838](VELOCITY_Z,0) = 0.000000; -NODES[14841](VELOCITY_X,0) = 0.000000; -NODES[14841](VELOCITY_Y,0) = 0.000000; -NODES[14841](VELOCITY_Z,0) = 0.000000; -NODES[14852](VELOCITY_X,0) = 0.000000; -NODES[14852](VELOCITY_Y,0) = 0.000000; -NODES[14852](VELOCITY_Z,0) = 0.000000; -NODES[14884](VELOCITY_X,0) = 0.000000; -NODES[14884](VELOCITY_Y,0) = 0.000000; -NODES[14884](VELOCITY_Z,0) = 0.000000; -NODES[14889](VELOCITY_X,0) = 0.000000; -NODES[14889](VELOCITY_Y,0) = 0.000000; -NODES[14889](VELOCITY_Z,0) = 0.000000; -NODES[14893](VELOCITY_X,0) = 0.000000; -NODES[14893](VELOCITY_Y,0) = 0.000000; -NODES[14893](VELOCITY_Z,0) = 0.000000; -NODES[14895](VELOCITY_X,0) = 0.000000; -NODES[14895](VELOCITY_Y,0) = 0.000000; -NODES[14895](VELOCITY_Z,0) = 0.000000; -NODES[14899](VELOCITY_X,0) = 0.000000; -NODES[14899](VELOCITY_Y,0) = 0.000000; -NODES[14899](VELOCITY_Z,0) = 0.000000; -NODES[14906](VELOCITY_X,0) = 0.000000; -NODES[14906](VELOCITY_Y,0) = 0.000000; -NODES[14906](VELOCITY_Z,0) = 0.000000; -NODES[14911](VELOCITY_X,0) = 0.000000; -NODES[14911](VELOCITY_Y,0) = 0.000000; -NODES[14911](VELOCITY_Z,0) = 0.000000; -NODES[14912](VELOCITY_X,0) = 0.000000; -NODES[14912](VELOCITY_Y,0) = 0.000000; -NODES[14912](VELOCITY_Z,0) = 0.000000; -NODES[14913](VELOCITY_X,0) = 0.000000; -NODES[14913](VELOCITY_Y,0) = 0.000000; -NODES[14913](VELOCITY_Z,0) = 0.000000; -NODES[14922](VELOCITY_X,0) = 0.000000; -NODES[14922](VELOCITY_Y,0) = 0.000000; -NODES[14922](VELOCITY_Z,0) = 0.000000; -NODES[14928](VELOCITY_X,0) = 0.000000; -NODES[14928](VELOCITY_Y,0) = 0.000000; -NODES[14928](VELOCITY_Z,0) = 0.000000; -NODES[14964](VELOCITY_X,0) = 0.000000; -NODES[14964](VELOCITY_Y,0) = 0.000000; -NODES[14964](VELOCITY_Z,0) = 0.000000; -NODES[14977](VELOCITY_X,0) = 0.000000; -NODES[14977](VELOCITY_Y,0) = 0.000000; -NODES[14977](VELOCITY_Z,0) = 0.000000; -NODES[14984](VELOCITY_X,0) = 0.000000; -NODES[14984](VELOCITY_Y,0) = 0.000000; -NODES[14984](VELOCITY_Z,0) = 0.000000; -NODES[14988](VELOCITY_X,0) = 0.000000; -NODES[14988](VELOCITY_Y,0) = 0.000000; -NODES[14988](VELOCITY_Z,0) = 0.000000; -NODES[14989](VELOCITY_X,0) = 0.000000; -NODES[14989](VELOCITY_Y,0) = 0.000000; -NODES[14989](VELOCITY_Z,0) = 0.000000; -NODES[14990](VELOCITY_X,0) = 0.000000; -NODES[14990](VELOCITY_Y,0) = 0.000000; -NODES[14990](VELOCITY_Z,0) = 0.000000; -NODES[14991](VELOCITY_X,0) = 0.000000; -NODES[14991](VELOCITY_Y,0) = 0.000000; -NODES[14991](VELOCITY_Z,0) = 0.000000; -NODES[14993](VELOCITY_X,0) = 0.000000; -NODES[14993](VELOCITY_Y,0) = 0.000000; -NODES[14993](VELOCITY_Z,0) = 0.000000; -NODES[14995](VELOCITY_X,0) = 0.000000; -NODES[14995](VELOCITY_Y,0) = 0.000000; -NODES[14995](VELOCITY_Z,0) = 0.000000; -NODES[14999](VELOCITY_X,0) = 0.000000; -NODES[14999](VELOCITY_Y,0) = 0.000000; -NODES[14999](VELOCITY_Z,0) = 0.000000; -NODES[15004](VELOCITY_X,0) = 0.000000; -NODES[15004](VELOCITY_Y,0) = 0.000000; -NODES[15004](VELOCITY_Z,0) = 0.000000; -NODES[15005](VELOCITY_X,0) = 0.000000; -NODES[15005](VELOCITY_Y,0) = 0.000000; -NODES[15005](VELOCITY_Z,0) = 0.000000; -NODES[15027](VELOCITY_X,0) = 0.000000; -NODES[15027](VELOCITY_Y,0) = 0.000000; -NODES[15027](VELOCITY_Z,0) = 0.000000; -NODES[15028](VELOCITY_X,0) = 0.000000; -NODES[15028](VELOCITY_Y,0) = 0.000000; -NODES[15028](VELOCITY_Z,0) = 0.000000; -NODES[15029](VELOCITY_X,0) = 0.000000; -NODES[15029](VELOCITY_Y,0) = 0.000000; -NODES[15029](VELOCITY_Z,0) = 0.000000; -NODES[15032](VELOCITY_X,0) = 0.000000; -NODES[15032](VELOCITY_Y,0) = 0.000000; -NODES[15032](VELOCITY_Z,0) = 0.000000; -NODES[15040](VELOCITY_X,0) = 0.000000; -NODES[15040](VELOCITY_Y,0) = 0.000000; -NODES[15040](VELOCITY_Z,0) = 0.000000; -NODES[15059](VELOCITY_X,0) = 0.000000; -NODES[15059](VELOCITY_Y,0) = 0.000000; -NODES[15059](VELOCITY_Z,0) = 0.000000; -NODES[15065](VELOCITY_X,0) = 0.000000; -NODES[15065](VELOCITY_Y,0) = 0.000000; -NODES[15065](VELOCITY_Z,0) = 0.000000; -NODES[15068](VELOCITY_X,0) = 0.000000; -NODES[15068](VELOCITY_Y,0) = 0.000000; -NODES[15068](VELOCITY_Z,0) = 0.000000; -NODES[15078](VELOCITY_X,0) = 0.000000; -NODES[15078](VELOCITY_Y,0) = 0.000000; -NODES[15078](VELOCITY_Z,0) = 0.000000; -NODES[15084](VELOCITY_X,0) = 0.000000; -NODES[15084](VELOCITY_Y,0) = 0.000000; -NODES[15084](VELOCITY_Z,0) = 0.000000; -NODES[15088](VELOCITY_X,0) = 0.000000; -NODES[15088](VELOCITY_Y,0) = 0.000000; -NODES[15088](VELOCITY_Z,0) = 0.000000; -NODES[15102](VELOCITY_X,0) = 0.000000; -NODES[15102](VELOCITY_Y,0) = 0.000000; -NODES[15102](VELOCITY_Z,0) = 0.000000; -NODES[15103](VELOCITY_X,0) = 0.000000; -NODES[15103](VELOCITY_Y,0) = 0.000000; -NODES[15103](VELOCITY_Z,0) = 0.000000; -NODES[15114](VELOCITY_X,0) = 0.000000; -NODES[15114](VELOCITY_Y,0) = 0.000000; -NODES[15114](VELOCITY_Z,0) = 0.000000; -NODES[15123](VELOCITY_X,0) = 0.000000; -NODES[15123](VELOCITY_Y,0) = 0.000000; -NODES[15123](VELOCITY_Z,0) = 0.000000; -NODES[15133](VELOCITY_X,0) = 0.000000; -NODES[15133](VELOCITY_Y,0) = 0.000000; -NODES[15133](VELOCITY_Z,0) = 0.000000; -NODES[15142](VELOCITY_X,0) = 0.000000; -NODES[15142](VELOCITY_Y,0) = 0.000000; -NODES[15142](VELOCITY_Z,0) = 0.000000; -NODES[15148](VELOCITY_X,0) = 0.000000; -NODES[15148](VELOCITY_Y,0) = 0.000000; -NODES[15148](VELOCITY_Z,0) = 0.000000; -NODES[15149](VELOCITY_X,0) = 0.000000; -NODES[15149](VELOCITY_Y,0) = 0.000000; -NODES[15149](VELOCITY_Z,0) = 0.000000; -NODES[15151](VELOCITY_X,0) = 0.000000; -NODES[15151](VELOCITY_Y,0) = 0.000000; -NODES[15151](VELOCITY_Z,0) = 0.000000; -NODES[15170](VELOCITY_X,0) = 0.000000; -NODES[15170](VELOCITY_Y,0) = 0.000000; -NODES[15170](VELOCITY_Z,0) = 0.000000; -NODES[15176](VELOCITY_X,0) = 0.000000; -NODES[15176](VELOCITY_Y,0) = 0.000000; -NODES[15176](VELOCITY_Z,0) = 0.000000; -NODES[15179](VELOCITY_X,0) = 0.000000; -NODES[15179](VELOCITY_Y,0) = 0.000000; -NODES[15179](VELOCITY_Z,0) = 0.000000; -NODES[15185](VELOCITY_X,0) = 0.000000; -NODES[15185](VELOCITY_Y,0) = 0.000000; -NODES[15185](VELOCITY_Z,0) = 0.000000; -NODES[15190](VELOCITY_X,0) = 0.000000; -NODES[15190](VELOCITY_Y,0) = 0.000000; -NODES[15190](VELOCITY_Z,0) = 0.000000; -NODES[15194](VELOCITY_X,0) = 0.000000; -NODES[15194](VELOCITY_Y,0) = 0.000000; -NODES[15194](VELOCITY_Z,0) = 0.000000; -NODES[15195](VELOCITY_X,0) = 0.000000; -NODES[15195](VELOCITY_Y,0) = 0.000000; -NODES[15195](VELOCITY_Z,0) = 0.000000; -NODES[15198](VELOCITY_X,0) = 0.000000; -NODES[15198](VELOCITY_Y,0) = 0.000000; -NODES[15198](VELOCITY_Z,0) = 0.000000; -NODES[15206](VELOCITY_X,0) = 0.000000; -NODES[15206](VELOCITY_Y,0) = 0.000000; -NODES[15206](VELOCITY_Z,0) = 0.000000; -NODES[15207](VELOCITY_X,0) = 0.000000; -NODES[15207](VELOCITY_Y,0) = 0.000000; -NODES[15207](VELOCITY_Z,0) = 0.000000; -NODES[15218](VELOCITY_X,0) = 0.000000; -NODES[15218](VELOCITY_Y,0) = 0.000000; -NODES[15218](VELOCITY_Z,0) = 0.000000; -NODES[15227](VELOCITY_X,0) = 0.000000; -NODES[15227](VELOCITY_Y,0) = 0.000000; -NODES[15227](VELOCITY_Z,0) = 0.000000; -NODES[15233](VELOCITY_X,0) = 0.000000; -NODES[15233](VELOCITY_Y,0) = 0.000000; -NODES[15233](VELOCITY_Z,0) = 0.000000; -NODES[15253](VELOCITY_X,0) = 0.000000; -NODES[15253](VELOCITY_Y,0) = 0.000000; -NODES[15253](VELOCITY_Z,0) = 0.000000; -NODES[15262](VELOCITY_X,0) = 0.000000; -NODES[15262](VELOCITY_Y,0) = 0.000000; -NODES[15262](VELOCITY_Z,0) = 0.000000; -NODES[15264](VELOCITY_X,0) = 0.000000; -NODES[15264](VELOCITY_Y,0) = 0.000000; -NODES[15264](VELOCITY_Z,0) = 0.000000; -NODES[15265](VELOCITY_X,0) = 0.000000; -NODES[15265](VELOCITY_Y,0) = 0.000000; -NODES[15265](VELOCITY_Z,0) = 0.000000; -NODES[15266](VELOCITY_X,0) = 0.000000; -NODES[15266](VELOCITY_Y,0) = 0.000000; -NODES[15266](VELOCITY_Z,0) = 0.000000; -NODES[15270](VELOCITY_X,0) = 0.000000; -NODES[15270](VELOCITY_Y,0) = 0.000000; -NODES[15270](VELOCITY_Z,0) = 0.000000; -NODES[15273](VELOCITY_X,0) = 0.000000; -NODES[15273](VELOCITY_Y,0) = 0.000000; -NODES[15273](VELOCITY_Z,0) = 0.000000; -NODES[15280](VELOCITY_X,0) = 0.000000; -NODES[15280](VELOCITY_Y,0) = 0.000000; -NODES[15280](VELOCITY_Z,0) = 0.000000; -NODES[15283](VELOCITY_X,0) = 0.000000; -NODES[15283](VELOCITY_Y,0) = 0.000000; -NODES[15283](VELOCITY_Z,0) = 0.000000; -NODES[15285](VELOCITY_X,0) = 0.000000; -NODES[15285](VELOCITY_Y,0) = 0.000000; -NODES[15285](VELOCITY_Z,0) = 0.000000; -NODES[15288](VELOCITY_X,0) = 0.000000; -NODES[15288](VELOCITY_Y,0) = 0.000000; -NODES[15288](VELOCITY_Z,0) = 0.000000; -NODES[15301](VELOCITY_X,0) = 0.000000; -NODES[15301](VELOCITY_Y,0) = 0.000000; -NODES[15301](VELOCITY_Z,0) = 0.000000; -NODES[15309](VELOCITY_X,0) = 0.000000; -NODES[15309](VELOCITY_Y,0) = 0.000000; -NODES[15309](VELOCITY_Z,0) = 0.000000; -NODES[15310](VELOCITY_X,0) = 0.000000; -NODES[15310](VELOCITY_Y,0) = 0.000000; -NODES[15310](VELOCITY_Z,0) = 0.000000; -NODES[15311](VELOCITY_X,0) = 0.000000; -NODES[15311](VELOCITY_Y,0) = 0.000000; -NODES[15311](VELOCITY_Z,0) = 0.000000; -NODES[15330](VELOCITY_X,0) = 0.000000; -NODES[15330](VELOCITY_Y,0) = 0.000000; -NODES[15330](VELOCITY_Z,0) = 0.000000; -NODES[15335](VELOCITY_X,0) = 0.000000; -NODES[15335](VELOCITY_Y,0) = 0.000000; -NODES[15335](VELOCITY_Z,0) = 0.000000; -NODES[15337](VELOCITY_X,0) = 0.000000; -NODES[15337](VELOCITY_Y,0) = 0.000000; -NODES[15337](VELOCITY_Z,0) = 0.000000; -NODES[15342](VELOCITY_X,0) = 0.000000; -NODES[15342](VELOCITY_Y,0) = 0.000000; -NODES[15342](VELOCITY_Z,0) = 0.000000; -NODES[15349](VELOCITY_X,0) = 0.000000; -NODES[15349](VELOCITY_Y,0) = 0.000000; -NODES[15349](VELOCITY_Z,0) = 0.000000; -NODES[15355](VELOCITY_X,0) = 0.000000; -NODES[15355](VELOCITY_Y,0) = 0.000000; -NODES[15355](VELOCITY_Z,0) = 0.000000; -NODES[15356](VELOCITY_X,0) = 0.000000; -NODES[15356](VELOCITY_Y,0) = 0.000000; -NODES[15356](VELOCITY_Z,0) = 0.000000; -NODES[15361](VELOCITY_X,0) = 0.000000; -NODES[15361](VELOCITY_Y,0) = 0.000000; -NODES[15361](VELOCITY_Z,0) = 0.000000; -NODES[15372](VELOCITY_X,0) = 0.000000; -NODES[15372](VELOCITY_Y,0) = 0.000000; -NODES[15372](VELOCITY_Z,0) = 0.000000; -NODES[15375](VELOCITY_X,0) = 0.000000; -NODES[15375](VELOCITY_Y,0) = 0.000000; -NODES[15375](VELOCITY_Z,0) = 0.000000; -NODES[15397](VELOCITY_X,0) = 0.000000; -NODES[15397](VELOCITY_Y,0) = 0.000000; -NODES[15397](VELOCITY_Z,0) = 0.000000; -NODES[15406](VELOCITY_X,0) = 0.000000; -NODES[15406](VELOCITY_Y,0) = 0.000000; -NODES[15406](VELOCITY_Z,0) = 0.000000; -NODES[15408](VELOCITY_X,0) = 0.000000; -NODES[15408](VELOCITY_Y,0) = 0.000000; -NODES[15408](VELOCITY_Z,0) = 0.000000; -NODES[15409](VELOCITY_X,0) = 0.000000; -NODES[15409](VELOCITY_Y,0) = 0.000000; -NODES[15409](VELOCITY_Z,0) = 0.000000; -NODES[15414](VELOCITY_X,0) = 0.000000; -NODES[15414](VELOCITY_Y,0) = 0.000000; -NODES[15414](VELOCITY_Z,0) = 0.000000; -NODES[15418](VELOCITY_X,0) = 0.000000; -NODES[15418](VELOCITY_Y,0) = 0.000000; -NODES[15418](VELOCITY_Z,0) = 0.000000; -NODES[15430](VELOCITY_X,0) = 0.000000; -NODES[15430](VELOCITY_Y,0) = 0.000000; -NODES[15430](VELOCITY_Z,0) = 0.000000; -NODES[15440](VELOCITY_X,0) = 0.000000; -NODES[15440](VELOCITY_Y,0) = 0.000000; -NODES[15440](VELOCITY_Z,0) = 0.000000; -NODES[15447](VELOCITY_X,0) = 0.000000; -NODES[15447](VELOCITY_Y,0) = 0.000000; -NODES[15447](VELOCITY_Z,0) = 0.000000; -NODES[15448](VELOCITY_X,0) = 0.000000; -NODES[15448](VELOCITY_Y,0) = 0.000000; -NODES[15448](VELOCITY_Z,0) = 0.000000; -NODES[15451](VELOCITY_X,0) = 0.000000; -NODES[15451](VELOCITY_Y,0) = 0.000000; -NODES[15451](VELOCITY_Z,0) = 0.000000; -NODES[15460](VELOCITY_X,0) = 0.000000; -NODES[15460](VELOCITY_Y,0) = 0.000000; -NODES[15460](VELOCITY_Z,0) = 0.000000; -NODES[15469](VELOCITY_X,0) = 0.000000; -NODES[15469](VELOCITY_Y,0) = 0.000000; -NODES[15469](VELOCITY_Z,0) = 0.000000; -NODES[15471](VELOCITY_X,0) = 0.000000; -NODES[15471](VELOCITY_Y,0) = 0.000000; -NODES[15471](VELOCITY_Z,0) = 0.000000; -NODES[15472](VELOCITY_X,0) = 0.000000; -NODES[15472](VELOCITY_Y,0) = 0.000000; -NODES[15472](VELOCITY_Z,0) = 0.000000; -NODES[15481](VELOCITY_X,0) = 0.000000; -NODES[15481](VELOCITY_Y,0) = 0.000000; -NODES[15481](VELOCITY_Z,0) = 0.000000; -NODES[15482](VELOCITY_X,0) = 0.000000; -NODES[15482](VELOCITY_Y,0) = 0.000000; -NODES[15482](VELOCITY_Z,0) = 0.000000; -NODES[15501](VELOCITY_X,0) = 0.000000; -NODES[15501](VELOCITY_Y,0) = 0.000000; -NODES[15501](VELOCITY_Z,0) = 0.000000; -NODES[15504](VELOCITY_X,0) = 0.000000; -NODES[15504](VELOCITY_Y,0) = 0.000000; -NODES[15504](VELOCITY_Z,0) = 0.000000; -NODES[15512](VELOCITY_X,0) = 0.000000; -NODES[15512](VELOCITY_Y,0) = 0.000000; -NODES[15512](VELOCITY_Z,0) = 0.000000; -NODES[15518](VELOCITY_X,0) = 0.000000; -NODES[15518](VELOCITY_Y,0) = 0.000000; -NODES[15518](VELOCITY_Z,0) = 0.000000; -NODES[15521](VELOCITY_X,0) = 0.000000; -NODES[15521](VELOCITY_Y,0) = 0.000000; -NODES[15521](VELOCITY_Z,0) = 0.000000; -NODES[15529](VELOCITY_X,0) = 0.000000; -NODES[15529](VELOCITY_Y,0) = 0.000000; -NODES[15529](VELOCITY_Z,0) = 0.000000; -NODES[15540](VELOCITY_X,0) = 0.000000; -NODES[15540](VELOCITY_Y,0) = 0.000000; -NODES[15540](VELOCITY_Z,0) = 0.000000; -NODES[15542](VELOCITY_X,0) = 0.000000; -NODES[15542](VELOCITY_Y,0) = 0.000000; -NODES[15542](VELOCITY_Z,0) = 0.000000; -NODES[15544](VELOCITY_X,0) = 0.000000; -NODES[15544](VELOCITY_Y,0) = 0.000000; -NODES[15544](VELOCITY_Z,0) = 0.000000; -NODES[15546](VELOCITY_X,0) = 0.000000; -NODES[15546](VELOCITY_Y,0) = 0.000000; -NODES[15546](VELOCITY_Z,0) = 0.000000; -NODES[15551](VELOCITY_X,0) = 0.000000; -NODES[15551](VELOCITY_Y,0) = 0.000000; -NODES[15551](VELOCITY_Z,0) = 0.000000; -NODES[15552](VELOCITY_X,0) = 0.000000; -NODES[15552](VELOCITY_Y,0) = 0.000000; -NODES[15552](VELOCITY_Z,0) = 0.000000; -NODES[15554](VELOCITY_X,0) = 0.000000; -NODES[15554](VELOCITY_Y,0) = 0.000000; -NODES[15554](VELOCITY_Z,0) = 0.000000; -NODES[15560](VELOCITY_X,0) = 0.000000; -NODES[15560](VELOCITY_Y,0) = 0.000000; -NODES[15560](VELOCITY_Z,0) = 0.000000; -NODES[15561](VELOCITY_X,0) = 0.000000; -NODES[15561](VELOCITY_Y,0) = 0.000000; -NODES[15561](VELOCITY_Z,0) = 0.000000; -NODES[15583](VELOCITY_X,0) = 0.000000; -NODES[15583](VELOCITY_Y,0) = 0.000000; -NODES[15583](VELOCITY_Z,0) = 0.000000; -NODES[15595](VELOCITY_X,0) = 0.000000; -NODES[15595](VELOCITY_Y,0) = 0.000000; -NODES[15595](VELOCITY_Z,0) = 0.000000; -NODES[15597](VELOCITY_X,0) = 0.000000; -NODES[15597](VELOCITY_Y,0) = 0.000000; -NODES[15597](VELOCITY_Z,0) = 0.000000; -NODES[15601](VELOCITY_X,0) = 0.000000; -NODES[15601](VELOCITY_Y,0) = 0.000000; -NODES[15601](VELOCITY_Z,0) = 0.000000; -NODES[15602](VELOCITY_X,0) = 0.000000; -NODES[15602](VELOCITY_Y,0) = 0.000000; -NODES[15602](VELOCITY_Z,0) = 0.000000; -NODES[15607](VELOCITY_X,0) = 0.000000; -NODES[15607](VELOCITY_Y,0) = 0.000000; -NODES[15607](VELOCITY_Z,0) = 0.000000; -NODES[15608](VELOCITY_X,0) = 0.000000; -NODES[15608](VELOCITY_Y,0) = 0.000000; -NODES[15608](VELOCITY_Z,0) = 0.000000; -NODES[15613](VELOCITY_X,0) = 0.000000; -NODES[15613](VELOCITY_Y,0) = 0.000000; -NODES[15613](VELOCITY_Z,0) = 0.000000; -NODES[15618](VELOCITY_X,0) = 0.000000; -NODES[15618](VELOCITY_Y,0) = 0.000000; -NODES[15618](VELOCITY_Z,0) = 0.000000; -NODES[15619](VELOCITY_X,0) = 0.000000; -NODES[15619](VELOCITY_Y,0) = 0.000000; -NODES[15619](VELOCITY_Z,0) = 0.000000; -NODES[15620](VELOCITY_X,0) = 0.000000; -NODES[15620](VELOCITY_Y,0) = 0.000000; -NODES[15620](VELOCITY_Z,0) = 0.000000; -NODES[15621](VELOCITY_X,0) = 0.000000; -NODES[15621](VELOCITY_Y,0) = 0.000000; -NODES[15621](VELOCITY_Z,0) = 0.000000; -NODES[15623](VELOCITY_X,0) = 0.000000; -NODES[15623](VELOCITY_Y,0) = 0.000000; -NODES[15623](VELOCITY_Z,0) = 0.000000; -NODES[15646](VELOCITY_X,0) = 0.000000; -NODES[15646](VELOCITY_Y,0) = 0.000000; -NODES[15646](VELOCITY_Z,0) = 0.000000; -NODES[15659](VELOCITY_X,0) = 0.000000; -NODES[15659](VELOCITY_Y,0) = 0.000000; -NODES[15659](VELOCITY_Z,0) = 0.000000; -NODES[15660](VELOCITY_X,0) = 0.000000; -NODES[15660](VELOCITY_Y,0) = 0.000000; -NODES[15660](VELOCITY_Z,0) = 0.000000; -NODES[15661](VELOCITY_X,0) = 0.000000; -NODES[15661](VELOCITY_Y,0) = 0.000000; -NODES[15661](VELOCITY_Z,0) = 0.000000; -NODES[15662](VELOCITY_X,0) = 0.000000; -NODES[15662](VELOCITY_Y,0) = 0.000000; -NODES[15662](VELOCITY_Z,0) = 0.000000; -NODES[15663](VELOCITY_X,0) = 0.000000; -NODES[15663](VELOCITY_Y,0) = 0.000000; -NODES[15663](VELOCITY_Z,0) = 0.000000; -NODES[15681](VELOCITY_X,0) = 0.000000; -NODES[15681](VELOCITY_Y,0) = 0.000000; -NODES[15681](VELOCITY_Z,0) = 0.000000; -NODES[15698](VELOCITY_X,0) = 0.000000; -NODES[15698](VELOCITY_Y,0) = 0.000000; -NODES[15698](VELOCITY_Z,0) = 0.000000; -NODES[15708](VELOCITY_X,0) = 0.000000; -NODES[15708](VELOCITY_Y,0) = 0.000000; -NODES[15708](VELOCITY_Z,0) = 0.000000; -NODES[15711](VELOCITY_X,0) = 0.000000; -NODES[15711](VELOCITY_Y,0) = 0.000000; -NODES[15711](VELOCITY_Z,0) = 0.000000; -NODES[15723](VELOCITY_X,0) = 0.000000; -NODES[15723](VELOCITY_Y,0) = 0.000000; -NODES[15723](VELOCITY_Z,0) = 0.000000; -NODES[15732](VELOCITY_X,0) = 0.000000; -NODES[15732](VELOCITY_Y,0) = 0.000000; -NODES[15732](VELOCITY_Z,0) = 0.000000; -NODES[15734](VELOCITY_X,0) = 0.000000; -NODES[15734](VELOCITY_Y,0) = 0.000000; -NODES[15734](VELOCITY_Z,0) = 0.000000; -NODES[15743](VELOCITY_X,0) = 0.000000; -NODES[15743](VELOCITY_Y,0) = 0.000000; -NODES[15743](VELOCITY_Z,0) = 0.000000; -NODES[15750](VELOCITY_X,0) = 0.000000; -NODES[15750](VELOCITY_Y,0) = 0.000000; -NODES[15750](VELOCITY_Z,0) = 0.000000; -NODES[15752](VELOCITY_X,0) = 0.000000; -NODES[15752](VELOCITY_Y,0) = 0.000000; -NODES[15752](VELOCITY_Z,0) = 0.000000; -NODES[15764](VELOCITY_X,0) = 0.000000; -NODES[15764](VELOCITY_Y,0) = 0.000000; -NODES[15764](VELOCITY_Z,0) = 0.000000; -NODES[15769](VELOCITY_X,0) = 0.000000; -NODES[15769](VELOCITY_Y,0) = 0.000000; -NODES[15769](VELOCITY_Z,0) = 0.000000; -NODES[15773](VELOCITY_X,0) = 0.000000; -NODES[15773](VELOCITY_Y,0) = 0.000000; -NODES[15773](VELOCITY_Z,0) = 0.000000; -NODES[15777](VELOCITY_X,0) = 0.000000; -NODES[15777](VELOCITY_Y,0) = 0.000000; -NODES[15777](VELOCITY_Z,0) = 0.000000; -NODES[15779](VELOCITY_X,0) = 0.000000; -NODES[15779](VELOCITY_Y,0) = 0.000000; -NODES[15779](VELOCITY_Z,0) = 0.000000; -NODES[15781](VELOCITY_X,0) = 0.000000; -NODES[15781](VELOCITY_Y,0) = 0.000000; -NODES[15781](VELOCITY_Z,0) = 0.000000; -NODES[15785](VELOCITY_X,0) = 0.000000; -NODES[15785](VELOCITY_Y,0) = 0.000000; -NODES[15785](VELOCITY_Z,0) = 0.000000; -NODES[15799](VELOCITY_X,0) = 0.000000; -NODES[15799](VELOCITY_Y,0) = 0.000000; -NODES[15799](VELOCITY_Z,0) = 0.000000; -NODES[15817](VELOCITY_X,0) = 0.000000; -NODES[15817](VELOCITY_Y,0) = 0.000000; -NODES[15817](VELOCITY_Z,0) = 0.000000; -NODES[15819](VELOCITY_X,0) = 0.000000; -NODES[15819](VELOCITY_Y,0) = 0.000000; -NODES[15819](VELOCITY_Z,0) = 0.000000; -NODES[15820](VELOCITY_X,0) = 0.000000; -NODES[15820](VELOCITY_Y,0) = 0.000000; -NODES[15820](VELOCITY_Z,0) = 0.000000; -NODES[15832](VELOCITY_X,0) = 0.000000; -NODES[15832](VELOCITY_Y,0) = 0.000000; -NODES[15832](VELOCITY_Z,0) = 0.000000; -NODES[15844](VELOCITY_X,0) = 0.000000; -NODES[15844](VELOCITY_Y,0) = 0.000000; -NODES[15844](VELOCITY_Z,0) = 0.000000; -NODES[15857](VELOCITY_X,0) = 0.000000; -NODES[15857](VELOCITY_Y,0) = 0.000000; -NODES[15857](VELOCITY_Z,0) = 0.000000; -NODES[15861](VELOCITY_X,0) = 0.000000; -NODES[15861](VELOCITY_Y,0) = 0.000000; -NODES[15861](VELOCITY_Z,0) = 0.000000; -NODES[15863](VELOCITY_X,0) = 0.000000; -NODES[15863](VELOCITY_Y,0) = 0.000000; -NODES[15863](VELOCITY_Z,0) = 0.000000; -NODES[15869](VELOCITY_X,0) = 0.000000; -NODES[15869](VELOCITY_Y,0) = 0.000000; -NODES[15869](VELOCITY_Z,0) = 0.000000; -NODES[15883](VELOCITY_X,0) = 0.000000; -NODES[15883](VELOCITY_Y,0) = 0.000000; -NODES[15883](VELOCITY_Z,0) = 0.000000; -NODES[15890](VELOCITY_X,0) = 0.000000; -NODES[15890](VELOCITY_Y,0) = 0.000000; -NODES[15890](VELOCITY_Z,0) = 0.000000; -NODES[15894](VELOCITY_X,0) = 0.000000; -NODES[15894](VELOCITY_Y,0) = 0.000000; -NODES[15894](VELOCITY_Z,0) = 0.000000; -NODES[15895](VELOCITY_X,0) = 0.000000; -NODES[15895](VELOCITY_Y,0) = 0.000000; -NODES[15895](VELOCITY_Z,0) = 0.000000; -NODES[15896](VELOCITY_X,0) = 0.000000; -NODES[15896](VELOCITY_Y,0) = 0.000000; -NODES[15896](VELOCITY_Z,0) = 0.000000; -NODES[15901](VELOCITY_X,0) = 0.000000; -NODES[15901](VELOCITY_Y,0) = 0.000000; -NODES[15901](VELOCITY_Z,0) = 0.000000; -NODES[15902](VELOCITY_X,0) = 0.000000; -NODES[15902](VELOCITY_Y,0) = 0.000000; -NODES[15902](VELOCITY_Z,0) = 0.000000; -NODES[15912](VELOCITY_X,0) = 0.000000; -NODES[15912](VELOCITY_Y,0) = 0.000000; -NODES[15912](VELOCITY_Z,0) = 0.000000; -NODES[15917](VELOCITY_X,0) = 0.000000; -NODES[15917](VELOCITY_Y,0) = 0.000000; -NODES[15917](VELOCITY_Z,0) = 0.000000; -NODES[15920](VELOCITY_X,0) = 0.000000; -NODES[15920](VELOCITY_Y,0) = 0.000000; -NODES[15920](VELOCITY_Z,0) = 0.000000; -NODES[15923](VELOCITY_X,0) = 0.000000; -NODES[15923](VELOCITY_Y,0) = 0.000000; -NODES[15923](VELOCITY_Z,0) = 0.000000; -NODES[15924](VELOCITY_X,0) = 0.000000; -NODES[15924](VELOCITY_Y,0) = 0.000000; -NODES[15924](VELOCITY_Z,0) = 0.000000; -NODES[15926](VELOCITY_X,0) = 0.000000; -NODES[15926](VELOCITY_Y,0) = 0.000000; -NODES[15926](VELOCITY_Z,0) = 0.000000; -NODES[15932](VELOCITY_X,0) = 0.000000; -NODES[15932](VELOCITY_Y,0) = 0.000000; -NODES[15932](VELOCITY_Z,0) = 0.000000; -NODES[15934](VELOCITY_X,0) = 0.000000; -NODES[15934](VELOCITY_Y,0) = 0.000000; -NODES[15934](VELOCITY_Z,0) = 0.000000; -NODES[15937](VELOCITY_X,0) = 0.000000; -NODES[15937](VELOCITY_Y,0) = 0.000000; -NODES[15937](VELOCITY_Z,0) = 0.000000; -NODES[15938](VELOCITY_X,0) = 0.000000; -NODES[15938](VELOCITY_Y,0) = 0.000000; -NODES[15938](VELOCITY_Z,0) = 0.000000; -NODES[15940](VELOCITY_X,0) = 0.000000; -NODES[15940](VELOCITY_Y,0) = 0.000000; -NODES[15940](VELOCITY_Z,0) = 0.000000; -NODES[15941](VELOCITY_X,0) = 0.000000; -NODES[15941](VELOCITY_Y,0) = 0.000000; -NODES[15941](VELOCITY_Z,0) = 0.000000; -NODES[15966](VELOCITY_X,0) = 0.000000; -NODES[15966](VELOCITY_Y,0) = 0.000000; -NODES[15966](VELOCITY_Z,0) = 0.000000; -NODES[15967](VELOCITY_X,0) = 0.000000; -NODES[15967](VELOCITY_Y,0) = 0.000000; -NODES[15967](VELOCITY_Z,0) = 0.000000; -NODES[15972](VELOCITY_X,0) = 0.000000; -NODES[15972](VELOCITY_Y,0) = 0.000000; -NODES[15972](VELOCITY_Z,0) = 0.000000; -NODES[15980](VELOCITY_X,0) = 0.000000; -NODES[15980](VELOCITY_Y,0) = 0.000000; -NODES[15980](VELOCITY_Z,0) = 0.000000; -NODES[15982](VELOCITY_X,0) = 0.000000; -NODES[15982](VELOCITY_Y,0) = 0.000000; -NODES[15982](VELOCITY_Z,0) = 0.000000; -NODES[15994](VELOCITY_X,0) = 0.000000; -NODES[15994](VELOCITY_Y,0) = 0.000000; -NODES[15994](VELOCITY_Z,0) = 0.000000; -NODES[15995](VELOCITY_X,0) = 0.000000; -NODES[15995](VELOCITY_Y,0) = 0.000000; -NODES[15995](VELOCITY_Z,0) = 0.000000; -NODES[16026](VELOCITY_X,0) = 0.000000; -NODES[16026](VELOCITY_Y,0) = 0.000000; -NODES[16026](VELOCITY_Z,0) = 0.000000; -NODES[16027](VELOCITY_X,0) = 0.000000; -NODES[16027](VELOCITY_Y,0) = 0.000000; -NODES[16027](VELOCITY_Z,0) = 0.000000; -NODES[16028](VELOCITY_X,0) = 0.000000; -NODES[16028](VELOCITY_Y,0) = 0.000000; -NODES[16028](VELOCITY_Z,0) = 0.000000; -NODES[16031](VELOCITY_X,0) = 0.000000; -NODES[16031](VELOCITY_Y,0) = 0.000000; -NODES[16031](VELOCITY_Z,0) = 0.000000; -NODES[16036](VELOCITY_X,0) = 0.000000; -NODES[16036](VELOCITY_Y,0) = 0.000000; -NODES[16036](VELOCITY_Z,0) = 0.000000; -NODES[16037](VELOCITY_X,0) = 0.000000; -NODES[16037](VELOCITY_Y,0) = 0.000000; -NODES[16037](VELOCITY_Z,0) = 0.000000; -NODES[16039](VELOCITY_X,0) = 0.000000; -NODES[16039](VELOCITY_Y,0) = 0.000000; -NODES[16039](VELOCITY_Z,0) = 0.000000; -NODES[16042](VELOCITY_X,0) = 0.000000; -NODES[16042](VELOCITY_Y,0) = 0.000000; -NODES[16042](VELOCITY_Z,0) = 0.000000; -NODES[16047](VELOCITY_X,0) = 0.000000; -NODES[16047](VELOCITY_Y,0) = 0.000000; -NODES[16047](VELOCITY_Z,0) = 0.000000; -NODES[16048](VELOCITY_X,0) = 0.000000; -NODES[16048](VELOCITY_Y,0) = 0.000000; -NODES[16048](VELOCITY_Z,0) = 0.000000; -NODES[16061](VELOCITY_X,0) = 0.000000; -NODES[16061](VELOCITY_Y,0) = 0.000000; -NODES[16061](VELOCITY_Z,0) = 0.000000; -NODES[16062](VELOCITY_X,0) = 0.000000; -NODES[16062](VELOCITY_Y,0) = 0.000000; -NODES[16062](VELOCITY_Z,0) = 0.000000; -NODES[16076](VELOCITY_X,0) = 0.000000; -NODES[16076](VELOCITY_Y,0) = 0.000000; -NODES[16076](VELOCITY_Z,0) = 0.000000; -NODES[16080](VELOCITY_X,0) = 0.000000; -NODES[16080](VELOCITY_Y,0) = 0.000000; -NODES[16080](VELOCITY_Z,0) = 0.000000; -NODES[16083](VELOCITY_X,0) = 0.000000; -NODES[16083](VELOCITY_Y,0) = 0.000000; -NODES[16083](VELOCITY_Z,0) = 0.000000; -NODES[16090](VELOCITY_X,0) = 0.000000; -NODES[16090](VELOCITY_Y,0) = 0.000000; -NODES[16090](VELOCITY_Z,0) = 0.000000; -NODES[16091](VELOCITY_X,0) = 0.000000; -NODES[16091](VELOCITY_Y,0) = 0.000000; -NODES[16091](VELOCITY_Z,0) = 0.000000; -NODES[16111](VELOCITY_X,0) = 0.000000; -NODES[16111](VELOCITY_Y,0) = 0.000000; -NODES[16111](VELOCITY_Z,0) = 0.000000; -NODES[16114](VELOCITY_X,0) = 0.000000; -NODES[16114](VELOCITY_Y,0) = 0.000000; -NODES[16114](VELOCITY_Z,0) = 0.000000; -NODES[16118](VELOCITY_X,0) = 0.000000; -NODES[16118](VELOCITY_Y,0) = 0.000000; -NODES[16118](VELOCITY_Z,0) = 0.000000; -NODES[16127](VELOCITY_X,0) = 0.000000; -NODES[16127](VELOCITY_Y,0) = 0.000000; -NODES[16127](VELOCITY_Z,0) = 0.000000; -NODES[16129](VELOCITY_X,0) = 0.000000; -NODES[16129](VELOCITY_Y,0) = 0.000000; -NODES[16129](VELOCITY_Z,0) = 0.000000; -NODES[16137](VELOCITY_X,0) = 0.000000; -NODES[16137](VELOCITY_Y,0) = 0.000000; -NODES[16137](VELOCITY_Z,0) = 0.000000; -NODES[16144](VELOCITY_X,0) = 0.000000; -NODES[16144](VELOCITY_Y,0) = 0.000000; -NODES[16144](VELOCITY_Z,0) = 0.000000; -NODES[16153](VELOCITY_X,0) = 0.000000; -NODES[16153](VELOCITY_Y,0) = 0.000000; -NODES[16153](VELOCITY_Z,0) = 0.000000; -NODES[16156](VELOCITY_X,0) = 0.000000; -NODES[16156](VELOCITY_Y,0) = 0.000000; -NODES[16156](VELOCITY_Z,0) = 0.000000; -NODES[16161](VELOCITY_X,0) = 0.000000; -NODES[16161](VELOCITY_Y,0) = 0.000000; -NODES[16161](VELOCITY_Z,0) = 0.000000; -NODES[16163](VELOCITY_X,0) = 0.000000; -NODES[16163](VELOCITY_Y,0) = 0.000000; -NODES[16163](VELOCITY_Z,0) = 0.000000; -NODES[16165](VELOCITY_X,0) = 0.000000; -NODES[16165](VELOCITY_Y,0) = 0.000000; -NODES[16165](VELOCITY_Z,0) = 0.000000; -NODES[16168](VELOCITY_X,0) = 0.000000; -NODES[16168](VELOCITY_Y,0) = 0.000000; -NODES[16168](VELOCITY_Z,0) = 0.000000; -NODES[16169](VELOCITY_X,0) = 0.000000; -NODES[16169](VELOCITY_Y,0) = 0.000000; -NODES[16169](VELOCITY_Z,0) = 0.000000; -NODES[16181](VELOCITY_X,0) = 0.000000; -NODES[16181](VELOCITY_Y,0) = 0.000000; -NODES[16181](VELOCITY_Z,0) = 0.000000; -NODES[16196](VELOCITY_X,0) = 0.000000; -NODES[16196](VELOCITY_Y,0) = 0.000000; -NODES[16196](VELOCITY_Z,0) = 0.000000; -NODES[16204](VELOCITY_X,0) = 0.000000; -NODES[16204](VELOCITY_Y,0) = 0.000000; -NODES[16204](VELOCITY_Z,0) = 0.000000; -NODES[16210](VELOCITY_X,0) = 0.000000; -NODES[16210](VELOCITY_Y,0) = 0.000000; -NODES[16210](VELOCITY_Z,0) = 0.000000; -NODES[16216](VELOCITY_X,0) = 0.000000; -NODES[16216](VELOCITY_Y,0) = 0.000000; -NODES[16216](VELOCITY_Z,0) = 0.000000; -NODES[16220](VELOCITY_X,0) = 0.000000; -NODES[16220](VELOCITY_Y,0) = 0.000000; -NODES[16220](VELOCITY_Z,0) = 0.000000; -NODES[16223](VELOCITY_X,0) = 0.000000; -NODES[16223](VELOCITY_Y,0) = 0.000000; -NODES[16223](VELOCITY_Z,0) = 0.000000; -NODES[16224](VELOCITY_X,0) = 0.000000; -NODES[16224](VELOCITY_Y,0) = 0.000000; -NODES[16224](VELOCITY_Z,0) = 0.000000; -NODES[16230](VELOCITY_X,0) = 0.000000; -NODES[16230](VELOCITY_Y,0) = 0.000000; -NODES[16230](VELOCITY_Z,0) = 0.000000; -NODES[16239](VELOCITY_X,0) = 0.000000; -NODES[16239](VELOCITY_Y,0) = 0.000000; -NODES[16239](VELOCITY_Z,0) = 0.000000; -NODES[16244](VELOCITY_X,0) = 0.000000; -NODES[16244](VELOCITY_Y,0) = 0.000000; -NODES[16244](VELOCITY_Z,0) = 0.000000; -NODES[16249](VELOCITY_X,0) = 0.000000; -NODES[16249](VELOCITY_Y,0) = 0.000000; -NODES[16249](VELOCITY_Z,0) = 0.000000; -NODES[16261](VELOCITY_X,0) = 0.000000; -NODES[16261](VELOCITY_Y,0) = 0.000000; -NODES[16261](VELOCITY_Z,0) = 0.000000; -NODES[16262](VELOCITY_X,0) = 0.000000; -NODES[16262](VELOCITY_Y,0) = 0.000000; -NODES[16262](VELOCITY_Z,0) = 0.000000; -NODES[16267](VELOCITY_X,0) = 0.000000; -NODES[16267](VELOCITY_Y,0) = 0.000000; -NODES[16267](VELOCITY_Z,0) = 0.000000; -NODES[16269](VELOCITY_X,0) = 0.000000; -NODES[16269](VELOCITY_Y,0) = 0.000000; -NODES[16269](VELOCITY_Z,0) = 0.000000; -NODES[16291](VELOCITY_X,0) = 0.000000; -NODES[16291](VELOCITY_Y,0) = 0.000000; -NODES[16291](VELOCITY_Z,0) = 0.000000; -NODES[16292](VELOCITY_X,0) = 0.000000; -NODES[16292](VELOCITY_Y,0) = 0.000000; -NODES[16292](VELOCITY_Z,0) = 0.000000; -NODES[16293](VELOCITY_X,0) = 0.000000; -NODES[16293](VELOCITY_Y,0) = 0.000000; -NODES[16293](VELOCITY_Z,0) = 0.000000; -NODES[16296](VELOCITY_X,0) = 0.000000; -NODES[16296](VELOCITY_Y,0) = 0.000000; -NODES[16296](VELOCITY_Z,0) = 0.000000; -NODES[16300](VELOCITY_X,0) = 0.000000; -NODES[16300](VELOCITY_Y,0) = 0.000000; -NODES[16300](VELOCITY_Z,0) = 0.000000; -NODES[16302](VELOCITY_X,0) = 0.000000; -NODES[16302](VELOCITY_Y,0) = 0.000000; -NODES[16302](VELOCITY_Z,0) = 0.000000; -NODES[16310](VELOCITY_X,0) = 0.000000; -NODES[16310](VELOCITY_Y,0) = 0.000000; -NODES[16310](VELOCITY_Z,0) = 0.000000; -NODES[16321](VELOCITY_X,0) = 0.000000; -NODES[16321](VELOCITY_Y,0) = 0.000000; -NODES[16321](VELOCITY_Z,0) = 0.000000; -NODES[16326](VELOCITY_X,0) = 0.000000; -NODES[16326](VELOCITY_Y,0) = 0.000000; -NODES[16326](VELOCITY_Z,0) = 0.000000; -NODES[16329](VELOCITY_X,0) = 0.000000; -NODES[16329](VELOCITY_Y,0) = 0.000000; -NODES[16329](VELOCITY_Z,0) = 0.000000; -NODES[16334](VELOCITY_X,0) = 0.000000; -NODES[16334](VELOCITY_Y,0) = 0.000000; -NODES[16334](VELOCITY_Z,0) = 0.000000; -NODES[16343](VELOCITY_X,0) = 0.000000; -NODES[16343](VELOCITY_Y,0) = 0.000000; -NODES[16343](VELOCITY_Z,0) = 0.000000; -NODES[16344](VELOCITY_X,0) = 0.000000; -NODES[16344](VELOCITY_Y,0) = 0.000000; -NODES[16344](VELOCITY_Z,0) = 0.000000; -NODES[16346](VELOCITY_X,0) = 0.000000; -NODES[16346](VELOCITY_Y,0) = 0.000000; -NODES[16346](VELOCITY_Z,0) = 0.000000; -NODES[16352](VELOCITY_X,0) = 0.000000; -NODES[16352](VELOCITY_Y,0) = 0.000000; -NODES[16352](VELOCITY_Z,0) = 0.000000; -NODES[16353](VELOCITY_X,0) = 0.000000; -NODES[16353](VELOCITY_Y,0) = 0.000000; -NODES[16353](VELOCITY_Z,0) = 0.000000; -NODES[16357](VELOCITY_X,0) = 0.000000; -NODES[16357](VELOCITY_Y,0) = 0.000000; -NODES[16357](VELOCITY_Z,0) = 0.000000; -NODES[16359](VELOCITY_X,0) = 0.000000; -NODES[16359](VELOCITY_Y,0) = 0.000000; -NODES[16359](VELOCITY_Z,0) = 0.000000; -NODES[16376](VELOCITY_X,0) = 0.000000; -NODES[16376](VELOCITY_Y,0) = 0.000000; -NODES[16376](VELOCITY_Z,0) = 0.000000; -NODES[16387](VELOCITY_X,0) = 0.000000; -NODES[16387](VELOCITY_Y,0) = 0.000000; -NODES[16387](VELOCITY_Z,0) = 0.000000; -NODES[16391](VELOCITY_X,0) = 0.000000; -NODES[16391](VELOCITY_Y,0) = 0.000000; -NODES[16391](VELOCITY_Z,0) = 0.000000; -NODES[16392](VELOCITY_X,0) = 0.000000; -NODES[16392](VELOCITY_Y,0) = 0.000000; -NODES[16392](VELOCITY_Z,0) = 0.000000; -NODES[16393](VELOCITY_X,0) = 0.000000; -NODES[16393](VELOCITY_Y,0) = 0.000000; -NODES[16393](VELOCITY_Z,0) = 0.000000; -NODES[16398](VELOCITY_X,0) = 0.000000; -NODES[16398](VELOCITY_Y,0) = 0.000000; -NODES[16398](VELOCITY_Z,0) = 0.000000; -NODES[16406](VELOCITY_X,0) = 0.000000; -NODES[16406](VELOCITY_Y,0) = 0.000000; -NODES[16406](VELOCITY_Z,0) = 0.000000; -NODES[16411](VELOCITY_X,0) = 0.000000; -NODES[16411](VELOCITY_Y,0) = 0.000000; -NODES[16411](VELOCITY_Z,0) = 0.000000; -NODES[16412](VELOCITY_X,0) = 0.000000; -NODES[16412](VELOCITY_Y,0) = 0.000000; -NODES[16412](VELOCITY_Z,0) = 0.000000; -NODES[16413](VELOCITY_X,0) = 0.000000; -NODES[16413](VELOCITY_Y,0) = 0.000000; -NODES[16413](VELOCITY_Z,0) = 0.000000; -NODES[16420](VELOCITY_X,0) = 0.000000; -NODES[16420](VELOCITY_Y,0) = 0.000000; -NODES[16420](VELOCITY_Z,0) = 0.000000; -NODES[16439](VELOCITY_X,0) = 0.000000; -NODES[16439](VELOCITY_Y,0) = 0.000000; -NODES[16439](VELOCITY_Z,0) = 0.000000; -NODES[16442](VELOCITY_X,0) = 0.000000; -NODES[16442](VELOCITY_Y,0) = 0.000000; -NODES[16442](VELOCITY_Z,0) = 0.000000; -NODES[16448](VELOCITY_X,0) = 0.000000; -NODES[16448](VELOCITY_Y,0) = 0.000000; -NODES[16448](VELOCITY_Z,0) = 0.000000; -NODES[16451](VELOCITY_X,0) = 0.000000; -NODES[16451](VELOCITY_Y,0) = 0.000000; -NODES[16451](VELOCITY_Z,0) = 0.000000; -NODES[16460](VELOCITY_X,0) = 0.000000; -NODES[16460](VELOCITY_Y,0) = 0.000000; -NODES[16460](VELOCITY_Z,0) = 0.000000; -NODES[16461](VELOCITY_X,0) = 0.000000; -NODES[16461](VELOCITY_Y,0) = 0.000000; -NODES[16461](VELOCITY_Z,0) = 0.000000; -NODES[16462](VELOCITY_X,0) = 0.000000; -NODES[16462](VELOCITY_Y,0) = 0.000000; -NODES[16462](VELOCITY_Z,0) = 0.000000; -NODES[16478](VELOCITY_X,0) = 0.000000; -NODES[16478](VELOCITY_Y,0) = 0.000000; -NODES[16478](VELOCITY_Z,0) = 0.000000; -NODES[16480](VELOCITY_X,0) = 0.000000; -NODES[16480](VELOCITY_Y,0) = 0.000000; -NODES[16480](VELOCITY_Z,0) = 0.000000; -NODES[16483](VELOCITY_X,0) = 0.000000; -NODES[16483](VELOCITY_Y,0) = 0.000000; -NODES[16483](VELOCITY_Z,0) = 0.000000; -NODES[16494](VELOCITY_X,0) = 0.000000; -NODES[16494](VELOCITY_Y,0) = 0.000000; -NODES[16494](VELOCITY_Z,0) = 0.000000; -NODES[16495](VELOCITY_X,0) = 0.000000; -NODES[16495](VELOCITY_Y,0) = 0.000000; -NODES[16495](VELOCITY_Z,0) = 0.000000; -NODES[16497](VELOCITY_X,0) = 0.000000; -NODES[16497](VELOCITY_Y,0) = 0.000000; -NODES[16497](VELOCITY_Z,0) = 0.000000; -NODES[16501](VELOCITY_X,0) = 0.000000; -NODES[16501](VELOCITY_Y,0) = 0.000000; -NODES[16501](VELOCITY_Z,0) = 0.000000; -NODES[16503](VELOCITY_X,0) = 0.000000; -NODES[16503](VELOCITY_Y,0) = 0.000000; -NODES[16503](VELOCITY_Z,0) = 0.000000; -NODES[16516](VELOCITY_X,0) = 0.000000; -NODES[16516](VELOCITY_Y,0) = 0.000000; -NODES[16516](VELOCITY_Z,0) = 0.000000; -NODES[16526](VELOCITY_X,0) = 0.000000; -NODES[16526](VELOCITY_Y,0) = 0.000000; -NODES[16526](VELOCITY_Z,0) = 0.000000; -NODES[16529](VELOCITY_X,0) = 0.000000; -NODES[16529](VELOCITY_Y,0) = 0.000000; -NODES[16529](VELOCITY_Z,0) = 0.000000; -NODES[16531](VELOCITY_X,0) = 0.000000; -NODES[16531](VELOCITY_Y,0) = 0.000000; -NODES[16531](VELOCITY_Z,0) = 0.000000; -NODES[16532](VELOCITY_X,0) = 0.000000; -NODES[16532](VELOCITY_Y,0) = 0.000000; -NODES[16532](VELOCITY_Z,0) = 0.000000; -NODES[16534](VELOCITY_X,0) = 0.000000; -NODES[16534](VELOCITY_Y,0) = 0.000000; -NODES[16534](VELOCITY_Z,0) = 0.000000; -NODES[16536](VELOCITY_X,0) = 0.000000; -NODES[16536](VELOCITY_Y,0) = 0.000000; -NODES[16536](VELOCITY_Z,0) = 0.000000; -NODES[16539](VELOCITY_X,0) = 0.000000; -NODES[16539](VELOCITY_Y,0) = 0.000000; -NODES[16539](VELOCITY_Z,0) = 0.000000; -NODES[16540](VELOCITY_X,0) = 0.000000; -NODES[16540](VELOCITY_Y,0) = 0.000000; -NODES[16540](VELOCITY_Z,0) = 0.000000; -NODES[16550](VELOCITY_X,0) = 0.000000; -NODES[16550](VELOCITY_Y,0) = 0.000000; -NODES[16550](VELOCITY_Z,0) = 0.000000; -NODES[16553](VELOCITY_X,0) = 0.000000; -NODES[16553](VELOCITY_Y,0) = 0.000000; -NODES[16553](VELOCITY_Z,0) = 0.000000; -NODES[16556](VELOCITY_X,0) = 0.000000; -NODES[16556](VELOCITY_Y,0) = 0.000000; -NODES[16556](VELOCITY_Z,0) = 0.000000; -NODES[16566](VELOCITY_X,0) = 0.000000; -NODES[16566](VELOCITY_Y,0) = 0.000000; -NODES[16566](VELOCITY_Z,0) = 0.000000; -NODES[16569](VELOCITY_X,0) = 0.000000; -NODES[16569](VELOCITY_Y,0) = 0.000000; -NODES[16569](VELOCITY_Z,0) = 0.000000; -NODES[16577](VELOCITY_X,0) = 0.000000; -NODES[16577](VELOCITY_Y,0) = 0.000000; -NODES[16577](VELOCITY_Z,0) = 0.000000; -NODES[16585](VELOCITY_X,0) = 0.000000; -NODES[16585](VELOCITY_Y,0) = 0.000000; -NODES[16585](VELOCITY_Z,0) = 0.000000; -NODES[16586](VELOCITY_X,0) = 0.000000; -NODES[16586](VELOCITY_Y,0) = 0.000000; -NODES[16586](VELOCITY_Z,0) = 0.000000; -NODES[16588](VELOCITY_X,0) = 0.000000; -NODES[16588](VELOCITY_Y,0) = 0.000000; -NODES[16588](VELOCITY_Z,0) = 0.000000; -NODES[16621](VELOCITY_X,0) = 0.000000; -NODES[16621](VELOCITY_Y,0) = 0.000000; -NODES[16621](VELOCITY_Z,0) = 0.000000; -NODES[16628](VELOCITY_X,0) = 0.000000; -NODES[16628](VELOCITY_Y,0) = 0.000000; -NODES[16628](VELOCITY_Z,0) = 0.000000; -NODES[16630](VELOCITY_X,0) = 0.000000; -NODES[16630](VELOCITY_Y,0) = 0.000000; -NODES[16630](VELOCITY_Z,0) = 0.000000; -NODES[16631](VELOCITY_X,0) = 0.000000; -NODES[16631](VELOCITY_Y,0) = 0.000000; -NODES[16631](VELOCITY_Z,0) = 0.000000; -NODES[16632](VELOCITY_X,0) = 0.000000; -NODES[16632](VELOCITY_Y,0) = 0.000000; -NODES[16632](VELOCITY_Z,0) = 0.000000; -NODES[16639](VELOCITY_X,0) = 0.000000; -NODES[16639](VELOCITY_Y,0) = 0.000000; -NODES[16639](VELOCITY_Z,0) = 0.000000; -NODES[16645](VELOCITY_X,0) = 0.000000; -NODES[16645](VELOCITY_Y,0) = 0.000000; -NODES[16645](VELOCITY_Z,0) = 0.000000; -NODES[16647](VELOCITY_X,0) = 0.000000; -NODES[16647](VELOCITY_Y,0) = 0.000000; -NODES[16647](VELOCITY_Z,0) = 0.000000; -NODES[16651](VELOCITY_X,0) = 0.000000; -NODES[16651](VELOCITY_Y,0) = 0.000000; -NODES[16651](VELOCITY_Z,0) = 0.000000; -NODES[16653](VELOCITY_X,0) = 0.000000; -NODES[16653](VELOCITY_Y,0) = 0.000000; -NODES[16653](VELOCITY_Z,0) = 0.000000; -NODES[16662](VELOCITY_X,0) = 0.000000; -NODES[16662](VELOCITY_Y,0) = 0.000000; -NODES[16662](VELOCITY_Z,0) = 0.000000; -NODES[16663](VELOCITY_X,0) = 0.000000; -NODES[16663](VELOCITY_Y,0) = 0.000000; -NODES[16663](VELOCITY_Z,0) = 0.000000; -NODES[16665](VELOCITY_X,0) = 0.000000; -NODES[16665](VELOCITY_Y,0) = 0.000000; -NODES[16665](VELOCITY_Z,0) = 0.000000; -NODES[16679](VELOCITY_X,0) = 0.000000; -NODES[16679](VELOCITY_Y,0) = 0.000000; -NODES[16679](VELOCITY_Z,0) = 0.000000; -NODES[16681](VELOCITY_X,0) = 0.000000; -NODES[16681](VELOCITY_Y,0) = 0.000000; -NODES[16681](VELOCITY_Z,0) = 0.000000; -NODES[16682](VELOCITY_X,0) = 0.000000; -NODES[16682](VELOCITY_Y,0) = 0.000000; -NODES[16682](VELOCITY_Z,0) = 0.000000; -NODES[16688](VELOCITY_X,0) = 0.000000; -NODES[16688](VELOCITY_Y,0) = 0.000000; -NODES[16688](VELOCITY_Z,0) = 0.000000; -NODES[16701](VELOCITY_X,0) = 0.000000; -NODES[16701](VELOCITY_Y,0) = 0.000000; -NODES[16701](VELOCITY_Z,0) = 0.000000; -NODES[16711](VELOCITY_X,0) = 0.000000; -NODES[16711](VELOCITY_Y,0) = 0.000000; -NODES[16711](VELOCITY_Z,0) = 0.000000; -NODES[16716](VELOCITY_X,0) = 0.000000; -NODES[16716](VELOCITY_Y,0) = 0.000000; -NODES[16716](VELOCITY_Z,0) = 0.000000; -NODES[16721](VELOCITY_X,0) = 0.000000; -NODES[16721](VELOCITY_Y,0) = 0.000000; -NODES[16721](VELOCITY_Z,0) = 0.000000; -NODES[16730](VELOCITY_X,0) = 0.000000; -NODES[16730](VELOCITY_Y,0) = 0.000000; -NODES[16730](VELOCITY_Z,0) = 0.000000; -NODES[16733](VELOCITY_X,0) = 0.000000; -NODES[16733](VELOCITY_Y,0) = 0.000000; -NODES[16733](VELOCITY_Z,0) = 0.000000; -NODES[16736](VELOCITY_X,0) = 0.000000; -NODES[16736](VELOCITY_Y,0) = 0.000000; -NODES[16736](VELOCITY_Z,0) = 0.000000; -NODES[16737](VELOCITY_X,0) = 0.000000; -NODES[16737](VELOCITY_Y,0) = 0.000000; -NODES[16737](VELOCITY_Z,0) = 0.000000; -NODES[16742](VELOCITY_X,0) = 0.000000; -NODES[16742](VELOCITY_Y,0) = 0.000000; -NODES[16742](VELOCITY_Z,0) = 0.000000; -NODES[16749](VELOCITY_X,0) = 0.000000; -NODES[16749](VELOCITY_Y,0) = 0.000000; -NODES[16749](VELOCITY_Z,0) = 0.000000; -NODES[16754](VELOCITY_X,0) = 0.000000; -NODES[16754](VELOCITY_Y,0) = 0.000000; -NODES[16754](VELOCITY_Z,0) = 0.000000; -NODES[16762](VELOCITY_X,0) = 0.000000; -NODES[16762](VELOCITY_Y,0) = 0.000000; -NODES[16762](VELOCITY_Z,0) = 0.000000; -NODES[16765](VELOCITY_X,0) = 0.000000; -NODES[16765](VELOCITY_Y,0) = 0.000000; -NODES[16765](VELOCITY_Z,0) = 0.000000; -NODES[16766](VELOCITY_X,0) = 0.000000; -NODES[16766](VELOCITY_Y,0) = 0.000000; -NODES[16766](VELOCITY_Z,0) = 0.000000; -NODES[16774](VELOCITY_X,0) = 0.000000; -NODES[16774](VELOCITY_Y,0) = 0.000000; -NODES[16774](VELOCITY_Z,0) = 0.000000; -NODES[16775](VELOCITY_X,0) = 0.000000; -NODES[16775](VELOCITY_Y,0) = 0.000000; -NODES[16775](VELOCITY_Z,0) = 0.000000; -NODES[16791](VELOCITY_X,0) = 0.000000; -NODES[16791](VELOCITY_Y,0) = 0.000000; -NODES[16791](VELOCITY_Z,0) = 0.000000; -NODES[16797](VELOCITY_X,0) = 0.000000; -NODES[16797](VELOCITY_Y,0) = 0.000000; -NODES[16797](VELOCITY_Z,0) = 0.000000; -NODES[16813](VELOCITY_X,0) = 0.000000; -NODES[16813](VELOCITY_Y,0) = 0.000000; -NODES[16813](VELOCITY_Z,0) = 0.000000; -NODES[16821](VELOCITY_X,0) = 0.000000; -NODES[16821](VELOCITY_Y,0) = 0.000000; -NODES[16821](VELOCITY_Z,0) = 0.000000; -NODES[16823](VELOCITY_X,0) = 0.000000; -NODES[16823](VELOCITY_Y,0) = 0.000000; -NODES[16823](VELOCITY_Z,0) = 0.000000; -NODES[16824](VELOCITY_X,0) = 0.000000; -NODES[16824](VELOCITY_Y,0) = 0.000000; -NODES[16824](VELOCITY_Z,0) = 0.000000; -NODES[16828](VELOCITY_X,0) = 0.000000; -NODES[16828](VELOCITY_Y,0) = 0.000000; -NODES[16828](VELOCITY_Z,0) = 0.000000; -NODES[16829](VELOCITY_X,0) = 0.000000; -NODES[16829](VELOCITY_Y,0) = 0.000000; -NODES[16829](VELOCITY_Z,0) = 0.000000; -NODES[16837](VELOCITY_X,0) = 0.000000; -NODES[16837](VELOCITY_Y,0) = 0.000000; -NODES[16837](VELOCITY_Z,0) = 0.000000; -NODES[16841](VELOCITY_X,0) = 0.000000; -NODES[16841](VELOCITY_Y,0) = 0.000000; -NODES[16841](VELOCITY_Z,0) = 0.000000; -NODES[16844](VELOCITY_X,0) = 0.000000; -NODES[16844](VELOCITY_Y,0) = 0.000000; -NODES[16844](VELOCITY_Z,0) = 0.000000; -NODES[16847](VELOCITY_X,0) = 0.000000; -NODES[16847](VELOCITY_Y,0) = 0.000000; -NODES[16847](VELOCITY_Z,0) = 0.000000; -NODES[16850](VELOCITY_X,0) = 0.000000; -NODES[16850](VELOCITY_Y,0) = 0.000000; -NODES[16850](VELOCITY_Z,0) = 0.000000; -NODES[16851](VELOCITY_X,0) = 0.000000; -NODES[16851](VELOCITY_Y,0) = 0.000000; -NODES[16851](VELOCITY_Z,0) = 0.000000; -NODES[16858](VELOCITY_X,0) = 0.000000; -NODES[16858](VELOCITY_Y,0) = 0.000000; -NODES[16858](VELOCITY_Z,0) = 0.000000; -NODES[16867](VELOCITY_X,0) = 0.000000; -NODES[16867](VELOCITY_Y,0) = 0.000000; -NODES[16867](VELOCITY_Z,0) = 0.000000; -NODES[16874](VELOCITY_X,0) = 0.000000; -NODES[16874](VELOCITY_Y,0) = 0.000000; -NODES[16874](VELOCITY_Z,0) = 0.000000; -NODES[16877](VELOCITY_X,0) = 0.000000; -NODES[16877](VELOCITY_Y,0) = 0.000000; -NODES[16877](VELOCITY_Z,0) = 0.000000; -NODES[16878](VELOCITY_X,0) = 0.000000; -NODES[16878](VELOCITY_Y,0) = 0.000000; -NODES[16878](VELOCITY_Z,0) = 0.000000; -NODES[16879](VELOCITY_X,0) = 0.000000; -NODES[16879](VELOCITY_Y,0) = 0.000000; -NODES[16879](VELOCITY_Z,0) = 0.000000; -NODES[16881](VELOCITY_X,0) = 0.000000; -NODES[16881](VELOCITY_Y,0) = 0.000000; -NODES[16881](VELOCITY_Z,0) = 0.000000; -NODES[16884](VELOCITY_X,0) = 0.000000; -NODES[16884](VELOCITY_Y,0) = 0.000000; -NODES[16884](VELOCITY_Z,0) = 0.000000; -NODES[16887](VELOCITY_X,0) = 0.000000; -NODES[16887](VELOCITY_Y,0) = 0.000000; -NODES[16887](VELOCITY_Z,0) = 0.000000; -NODES[16899](VELOCITY_X,0) = 0.000000; -NODES[16899](VELOCITY_Y,0) = 0.000000; -NODES[16899](VELOCITY_Z,0) = 0.000000; -NODES[16906](VELOCITY_X,0) = 0.000000; -NODES[16906](VELOCITY_Y,0) = 0.000000; -NODES[16906](VELOCITY_Z,0) = 0.000000; -NODES[16907](VELOCITY_X,0) = 0.000000; -NODES[16907](VELOCITY_Y,0) = 0.000000; -NODES[16907](VELOCITY_Z,0) = 0.000000; -NODES[16908](VELOCITY_X,0) = 0.000000; -NODES[16908](VELOCITY_Y,0) = 0.000000; -NODES[16908](VELOCITY_Z,0) = 0.000000; -NODES[16939](VELOCITY_X,0) = 0.000000; -NODES[16939](VELOCITY_Y,0) = 0.000000; -NODES[16939](VELOCITY_Z,0) = 0.000000; -NODES[16940](VELOCITY_X,0) = 0.000000; -NODES[16940](VELOCITY_Y,0) = 0.000000; -NODES[16940](VELOCITY_Z,0) = 0.000000; -NODES[16952](VELOCITY_X,0) = 0.000000; -NODES[16952](VELOCITY_Y,0) = 0.000000; -NODES[16952](VELOCITY_Z,0) = 0.000000; -NODES[16953](VELOCITY_X,0) = 0.000000; -NODES[16953](VELOCITY_Y,0) = 0.000000; -NODES[16953](VELOCITY_Z,0) = 0.000000; -NODES[16955](VELOCITY_X,0) = 0.000000; -NODES[16955](VELOCITY_Y,0) = 0.000000; -NODES[16955](VELOCITY_Z,0) = 0.000000; -NODES[16962](VELOCITY_X,0) = 0.000000; -NODES[16962](VELOCITY_Y,0) = 0.000000; -NODES[16962](VELOCITY_Z,0) = 0.000000; -NODES[16966](VELOCITY_X,0) = 0.000000; -NODES[16966](VELOCITY_Y,0) = 0.000000; -NODES[16966](VELOCITY_Z,0) = 0.000000; -NODES[16970](VELOCITY_X,0) = 0.000000; -NODES[16970](VELOCITY_Y,0) = 0.000000; -NODES[16970](VELOCITY_Z,0) = 0.000000; -NODES[16974](VELOCITY_X,0) = 0.000000; -NODES[16974](VELOCITY_Y,0) = 0.000000; -NODES[16974](VELOCITY_Z,0) = 0.000000; -NODES[16986](VELOCITY_X,0) = 0.000000; -NODES[16986](VELOCITY_Y,0) = 0.000000; -NODES[16986](VELOCITY_Z,0) = 0.000000; -NODES[16990](VELOCITY_X,0) = 0.000000; -NODES[16990](VELOCITY_Y,0) = 0.000000; -NODES[16990](VELOCITY_Z,0) = 0.000000; -NODES[16993](VELOCITY_X,0) = 0.000000; -NODES[16993](VELOCITY_Y,0) = 0.000000; -NODES[16993](VELOCITY_Z,0) = 0.000000; -NODES[16995](VELOCITY_X,0) = 0.000000; -NODES[16995](VELOCITY_Y,0) = 0.000000; -NODES[16995](VELOCITY_Z,0) = 0.000000; -NODES[16996](VELOCITY_X,0) = 0.000000; -NODES[16996](VELOCITY_Y,0) = 0.000000; -NODES[16996](VELOCITY_Z,0) = 0.000000; -NODES[16997](VELOCITY_X,0) = 0.000000; -NODES[16997](VELOCITY_Y,0) = 0.000000; -NODES[16997](VELOCITY_Z,0) = 0.000000; -NODES[17000](VELOCITY_X,0) = 0.000000; -NODES[17000](VELOCITY_Y,0) = 0.000000; -NODES[17000](VELOCITY_Z,0) = 0.000000; -NODES[17009](VELOCITY_X,0) = 0.000000; -NODES[17009](VELOCITY_Y,0) = 0.000000; -NODES[17009](VELOCITY_Z,0) = 0.000000; -NODES[17010](VELOCITY_X,0) = 0.000000; -NODES[17010](VELOCITY_Y,0) = 0.000000; -NODES[17010](VELOCITY_Z,0) = 0.000000; -NODES[17015](VELOCITY_X,0) = 0.000000; -NODES[17015](VELOCITY_Y,0) = 0.000000; -NODES[17015](VELOCITY_Z,0) = 0.000000; -NODES[17016](VELOCITY_X,0) = 0.000000; -NODES[17016](VELOCITY_Y,0) = 0.000000; -NODES[17016](VELOCITY_Z,0) = 0.000000; -NODES[17029](VELOCITY_X,0) = 0.000000; -NODES[17029](VELOCITY_Y,0) = 0.000000; -NODES[17029](VELOCITY_Z,0) = 0.000000; -NODES[17030](VELOCITY_X,0) = 0.000000; -NODES[17030](VELOCITY_Y,0) = 0.000000; -NODES[17030](VELOCITY_Z,0) = 0.000000; -NODES[17034](VELOCITY_X,0) = 0.000000; -NODES[17034](VELOCITY_Y,0) = 0.000000; -NODES[17034](VELOCITY_Z,0) = 0.000000; -NODES[17039](VELOCITY_X,0) = 0.000000; -NODES[17039](VELOCITY_Y,0) = 0.000000; -NODES[17039](VELOCITY_Z,0) = 0.000000; -NODES[17042](VELOCITY_X,0) = 0.000000; -NODES[17042](VELOCITY_Y,0) = 0.000000; -NODES[17042](VELOCITY_Z,0) = 0.000000; -NODES[17043](VELOCITY_X,0) = 0.000000; -NODES[17043](VELOCITY_Y,0) = 0.000000; -NODES[17043](VELOCITY_Z,0) = 0.000000; -NODES[17047](VELOCITY_X,0) = 0.000000; -NODES[17047](VELOCITY_Y,0) = 0.000000; -NODES[17047](VELOCITY_Z,0) = 0.000000; -NODES[17055](VELOCITY_X,0) = 0.000000; -NODES[17055](VELOCITY_Y,0) = 0.000000; -NODES[17055](VELOCITY_Z,0) = 0.000000; -NODES[17062](VELOCITY_X,0) = 0.000000; -NODES[17062](VELOCITY_Y,0) = 0.000000; -NODES[17062](VELOCITY_Z,0) = 0.000000; -NODES[17064](VELOCITY_X,0) = 0.000000; -NODES[17064](VELOCITY_Y,0) = 0.000000; -NODES[17064](VELOCITY_Z,0) = 0.000000; -NODES[17072](VELOCITY_X,0) = 0.000000; -NODES[17072](VELOCITY_Y,0) = 0.000000; -NODES[17072](VELOCITY_Z,0) = 0.000000; -NODES[17077](VELOCITY_X,0) = 0.000000; -NODES[17077](VELOCITY_Y,0) = 0.000000; -NODES[17077](VELOCITY_Z,0) = 0.000000; -NODES[17081](VELOCITY_X,0) = 0.000000; -NODES[17081](VELOCITY_Y,0) = 0.000000; -NODES[17081](VELOCITY_Z,0) = 0.000000; -NODES[17092](VELOCITY_X,0) = 0.000000; -NODES[17092](VELOCITY_Y,0) = 0.000000; -NODES[17092](VELOCITY_Z,0) = 0.000000; -NODES[17093](VELOCITY_X,0) = 0.000000; -NODES[17093](VELOCITY_Y,0) = 0.000000; -NODES[17093](VELOCITY_Z,0) = 0.000000; -NODES[17104](VELOCITY_X,0) = 0.000000; -NODES[17104](VELOCITY_Y,0) = 0.000000; -NODES[17104](VELOCITY_Z,0) = 0.000000; -NODES[17106](VELOCITY_X,0) = 0.000000; -NODES[17106](VELOCITY_Y,0) = 0.000000; -NODES[17106](VELOCITY_Z,0) = 0.000000; -NODES[17110](VELOCITY_X,0) = 0.000000; -NODES[17110](VELOCITY_Y,0) = 0.000000; -NODES[17110](VELOCITY_Z,0) = 0.000000; -NODES[17111](VELOCITY_X,0) = 0.000000; -NODES[17111](VELOCITY_Y,0) = 0.000000; -NODES[17111](VELOCITY_Z,0) = 0.000000; -NODES[17112](VELOCITY_X,0) = 0.000000; -NODES[17112](VELOCITY_Y,0) = 0.000000; -NODES[17112](VELOCITY_Z,0) = 0.000000; -NODES[17115](VELOCITY_X,0) = 0.000000; -NODES[17115](VELOCITY_Y,0) = 0.000000; -NODES[17115](VELOCITY_Z,0) = 0.000000; -NODES[17124](VELOCITY_X,0) = 0.000000; -NODES[17124](VELOCITY_Y,0) = 0.000000; -NODES[17124](VELOCITY_Z,0) = 0.000000; -NODES[17125](VELOCITY_X,0) = 0.000000; -NODES[17125](VELOCITY_Y,0) = 0.000000; -NODES[17125](VELOCITY_Z,0) = 0.000000; -NODES[17133](VELOCITY_X,0) = 0.000000; -NODES[17133](VELOCITY_Y,0) = 0.000000; -NODES[17133](VELOCITY_Z,0) = 0.000000; -NODES[17142](VELOCITY_X,0) = 0.000000; -NODES[17142](VELOCITY_Y,0) = 0.000000; -NODES[17142](VELOCITY_Z,0) = 0.000000; -NODES[17145](VELOCITY_X,0) = 0.000000; -NODES[17145](VELOCITY_Y,0) = 0.000000; -NODES[17145](VELOCITY_Z,0) = 0.000000; -NODES[17152](VELOCITY_X,0) = 0.000000; -NODES[17152](VELOCITY_Y,0) = 0.000000; -NODES[17152](VELOCITY_Z,0) = 0.000000; -NODES[17153](VELOCITY_X,0) = 0.000000; -NODES[17153](VELOCITY_Y,0) = 0.000000; -NODES[17153](VELOCITY_Z,0) = 0.000000; -NODES[17158](VELOCITY_X,0) = 0.000000; -NODES[17158](VELOCITY_Y,0) = 0.000000; -NODES[17158](VELOCITY_Z,0) = 0.000000; -NODES[17161](VELOCITY_X,0) = 0.000000; -NODES[17161](VELOCITY_Y,0) = 0.000000; -NODES[17161](VELOCITY_Z,0) = 0.000000; -NODES[17167](VELOCITY_X,0) = 0.000000; -NODES[17167](VELOCITY_Y,0) = 0.000000; -NODES[17167](VELOCITY_Z,0) = 0.000000; -NODES[17169](VELOCITY_X,0) = 0.000000; -NODES[17169](VELOCITY_Y,0) = 0.000000; -NODES[17169](VELOCITY_Z,0) = 0.000000; -NODES[17190](VELOCITY_X,0) = 0.000000; -NODES[17190](VELOCITY_Y,0) = 0.000000; -NODES[17190](VELOCITY_Z,0) = 0.000000; -NODES[17191](VELOCITY_X,0) = 0.000000; -NODES[17191](VELOCITY_Y,0) = 0.000000; -NODES[17191](VELOCITY_Z,0) = 0.000000; -NODES[17193](VELOCITY_X,0) = 0.000000; -NODES[17193](VELOCITY_Y,0) = 0.000000; -NODES[17193](VELOCITY_Z,0) = 0.000000; -NODES[17194](VELOCITY_X,0) = 0.000000; -NODES[17194](VELOCITY_Y,0) = 0.000000; -NODES[17194](VELOCITY_Z,0) = 0.000000; -NODES[17196](VELOCITY_X,0) = 0.000000; -NODES[17196](VELOCITY_Y,0) = 0.000000; -NODES[17196](VELOCITY_Z,0) = 0.000000; -NODES[17197](VELOCITY_X,0) = 0.000000; -NODES[17197](VELOCITY_Y,0) = 0.000000; -NODES[17197](VELOCITY_Z,0) = 0.000000; -NODES[17200](VELOCITY_X,0) = 0.000000; -NODES[17200](VELOCITY_Y,0) = 0.000000; -NODES[17200](VELOCITY_Z,0) = 0.000000; -NODES[17202](VELOCITY_X,0) = 0.000000; -NODES[17202](VELOCITY_Y,0) = 0.000000; -NODES[17202](VELOCITY_Z,0) = 0.000000; -NODES[17209](VELOCITY_X,0) = 0.000000; -NODES[17209](VELOCITY_Y,0) = 0.000000; -NODES[17209](VELOCITY_Z,0) = 0.000000; -NODES[17211](VELOCITY_X,0) = 0.000000; -NODES[17211](VELOCITY_Y,0) = 0.000000; -NODES[17211](VELOCITY_Z,0) = 0.000000; -NODES[17233](VELOCITY_X,0) = 0.000000; -NODES[17233](VELOCITY_Y,0) = 0.000000; -NODES[17233](VELOCITY_Z,0) = 0.000000; -NODES[17235](VELOCITY_X,0) = 0.000000; -NODES[17235](VELOCITY_Y,0) = 0.000000; -NODES[17235](VELOCITY_Z,0) = 0.000000; -NODES[17238](VELOCITY_X,0) = 0.000000; -NODES[17238](VELOCITY_Y,0) = 0.000000; -NODES[17238](VELOCITY_Z,0) = 0.000000; -NODES[17240](VELOCITY_X,0) = 0.000000; -NODES[17240](VELOCITY_Y,0) = 0.000000; -NODES[17240](VELOCITY_Z,0) = 0.000000; -NODES[17245](VELOCITY_X,0) = 0.000000; -NODES[17245](VELOCITY_Y,0) = 0.000000; -NODES[17245](VELOCITY_Z,0) = 0.000000; -NODES[17262](VELOCITY_X,0) = 0.000000; -NODES[17262](VELOCITY_Y,0) = 0.000000; -NODES[17262](VELOCITY_Z,0) = 0.000000; -NODES[17266](VELOCITY_X,0) = 0.000000; -NODES[17266](VELOCITY_Y,0) = 0.000000; -NODES[17266](VELOCITY_Z,0) = 0.000000; -NODES[17270](VELOCITY_X,0) = 0.000000; -NODES[17270](VELOCITY_Y,0) = 0.000000; -NODES[17270](VELOCITY_Z,0) = 0.000000; -NODES[17272](VELOCITY_X,0) = 0.000000; -NODES[17272](VELOCITY_Y,0) = 0.000000; -NODES[17272](VELOCITY_Z,0) = 0.000000; -NODES[17276](VELOCITY_X,0) = 0.000000; -NODES[17276](VELOCITY_Y,0) = 0.000000; -NODES[17276](VELOCITY_Z,0) = 0.000000; -NODES[17278](VELOCITY_X,0) = 0.000000; -NODES[17278](VELOCITY_Y,0) = 0.000000; -NODES[17278](VELOCITY_Z,0) = 0.000000; -NODES[17279](VELOCITY_X,0) = 0.000000; -NODES[17279](VELOCITY_Y,0) = 0.000000; -NODES[17279](VELOCITY_Z,0) = 0.000000; -NODES[17284](VELOCITY_X,0) = 0.000000; -NODES[17284](VELOCITY_Y,0) = 0.000000; -NODES[17284](VELOCITY_Z,0) = 0.000000; -NODES[17287](VELOCITY_X,0) = 0.000000; -NODES[17287](VELOCITY_Y,0) = 0.000000; -NODES[17287](VELOCITY_Z,0) = 0.000000; -NODES[17295](VELOCITY_X,0) = 0.000000; -NODES[17295](VELOCITY_Y,0) = 0.000000; -NODES[17295](VELOCITY_Z,0) = 0.000000; -NODES[17299](VELOCITY_X,0) = 0.000000; -NODES[17299](VELOCITY_Y,0) = 0.000000; -NODES[17299](VELOCITY_Z,0) = 0.000000; -NODES[17300](VELOCITY_X,0) = 0.000000; -NODES[17300](VELOCITY_Y,0) = 0.000000; -NODES[17300](VELOCITY_Z,0) = 0.000000; -NODES[17302](VELOCITY_X,0) = 0.000000; -NODES[17302](VELOCITY_Y,0) = 0.000000; -NODES[17302](VELOCITY_Z,0) = 0.000000; -NODES[17327](VELOCITY_X,0) = 0.000000; -NODES[17327](VELOCITY_Y,0) = 0.000000; -NODES[17327](VELOCITY_Z,0) = 0.000000; -NODES[17330](VELOCITY_X,0) = 0.000000; -NODES[17330](VELOCITY_Y,0) = 0.000000; -NODES[17330](VELOCITY_Z,0) = 0.000000; -NODES[17347](VELOCITY_X,0) = 0.000000; -NODES[17347](VELOCITY_Y,0) = 0.000000; -NODES[17347](VELOCITY_Z,0) = 0.000000; -NODES[17357](VELOCITY_X,0) = 0.000000; -NODES[17357](VELOCITY_Y,0) = 0.000000; -NODES[17357](VELOCITY_Z,0) = 0.000000; -NODES[17359](VELOCITY_X,0) = 0.000000; -NODES[17359](VELOCITY_Y,0) = 0.000000; -NODES[17359](VELOCITY_Z,0) = 0.000000; -NODES[17361](VELOCITY_X,0) = 0.000000; -NODES[17361](VELOCITY_Y,0) = 0.000000; -NODES[17361](VELOCITY_Z,0) = 0.000000; -NODES[17365](VELOCITY_X,0) = 0.000000; -NODES[17365](VELOCITY_Y,0) = 0.000000; -NODES[17365](VELOCITY_Z,0) = 0.000000; -NODES[17366](VELOCITY_X,0) = 0.000000; -NODES[17366](VELOCITY_Y,0) = 0.000000; -NODES[17366](VELOCITY_Z,0) = 0.000000; -NODES[17368](VELOCITY_X,0) = 0.000000; -NODES[17368](VELOCITY_Y,0) = 0.000000; -NODES[17368](VELOCITY_Z,0) = 0.000000; -NODES[17370](VELOCITY_X,0) = 0.000000; -NODES[17370](VELOCITY_Y,0) = 0.000000; -NODES[17370](VELOCITY_Z,0) = 0.000000; -NODES[17371](VELOCITY_X,0) = 0.000000; -NODES[17371](VELOCITY_Y,0) = 0.000000; -NODES[17371](VELOCITY_Z,0) = 0.000000; -NODES[17376](VELOCITY_X,0) = 0.000000; -NODES[17376](VELOCITY_Y,0) = 0.000000; -NODES[17376](VELOCITY_Z,0) = 0.000000; -NODES[17382](VELOCITY_X,0) = 0.000000; -NODES[17382](VELOCITY_Y,0) = 0.000000; -NODES[17382](VELOCITY_Z,0) = 0.000000; -NODES[17386](VELOCITY_X,0) = 0.000000; -NODES[17386](VELOCITY_Y,0) = 0.000000; -NODES[17386](VELOCITY_Z,0) = 0.000000; -NODES[17390](VELOCITY_X,0) = 0.000000; -NODES[17390](VELOCITY_Y,0) = 0.000000; -NODES[17390](VELOCITY_Z,0) = 0.000000; -NODES[17392](VELOCITY_X,0) = 0.000000; -NODES[17392](VELOCITY_Y,0) = 0.000000; -NODES[17392](VELOCITY_Z,0) = 0.000000; -NODES[17395](VELOCITY_X,0) = 0.000000; -NODES[17395](VELOCITY_Y,0) = 0.000000; -NODES[17395](VELOCITY_Z,0) = 0.000000; -NODES[17400](VELOCITY_X,0) = 0.000000; -NODES[17400](VELOCITY_Y,0) = 0.000000; -NODES[17400](VELOCITY_Z,0) = 0.000000; -NODES[17403](VELOCITY_X,0) = 0.000000; -NODES[17403](VELOCITY_Y,0) = 0.000000; -NODES[17403](VELOCITY_Z,0) = 0.000000; -NODES[17404](VELOCITY_X,0) = 0.000000; -NODES[17404](VELOCITY_Y,0) = 0.000000; -NODES[17404](VELOCITY_Z,0) = 0.000000; -NODES[17411](VELOCITY_X,0) = 0.000000; -NODES[17411](VELOCITY_Y,0) = 0.000000; -NODES[17411](VELOCITY_Z,0) = 0.000000; -NODES[17413](VELOCITY_X,0) = 0.000000; -NODES[17413](VELOCITY_Y,0) = 0.000000; -NODES[17413](VELOCITY_Z,0) = 0.000000; -NODES[17418](VELOCITY_X,0) = 0.000000; -NODES[17418](VELOCITY_Y,0) = 0.000000; -NODES[17418](VELOCITY_Z,0) = 0.000000; -NODES[17422](VELOCITY_X,0) = 0.000000; -NODES[17422](VELOCITY_Y,0) = 0.000000; -NODES[17422](VELOCITY_Z,0) = 0.000000; -NODES[17427](VELOCITY_X,0) = 0.000000; -NODES[17427](VELOCITY_Y,0) = 0.000000; -NODES[17427](VELOCITY_Z,0) = 0.000000; -NODES[17436](VELOCITY_X,0) = 0.000000; -NODES[17436](VELOCITY_Y,0) = 0.000000; -NODES[17436](VELOCITY_Z,0) = 0.000000; -NODES[17440](VELOCITY_X,0) = 0.000000; -NODES[17440](VELOCITY_Y,0) = 0.000000; -NODES[17440](VELOCITY_Z,0) = 0.000000; -NODES[17442](VELOCITY_X,0) = 0.000000; -NODES[17442](VELOCITY_Y,0) = 0.000000; -NODES[17442](VELOCITY_Z,0) = 0.000000; -NODES[17453](VELOCITY_X,0) = 0.000000; -NODES[17453](VELOCITY_Y,0) = 0.000000; -NODES[17453](VELOCITY_Z,0) = 0.000000; -NODES[17455](VELOCITY_X,0) = 0.000000; -NODES[17455](VELOCITY_Y,0) = 0.000000; -NODES[17455](VELOCITY_Z,0) = 0.000000; -NODES[17459](VELOCITY_X,0) = 0.000000; -NODES[17459](VELOCITY_Y,0) = 0.000000; -NODES[17459](VELOCITY_Z,0) = 0.000000; -NODES[17465](VELOCITY_X,0) = 0.000000; -NODES[17465](VELOCITY_Y,0) = 0.000000; -NODES[17465](VELOCITY_Z,0) = 0.000000; -NODES[17466](VELOCITY_X,0) = 0.000000; -NODES[17466](VELOCITY_Y,0) = 0.000000; -NODES[17466](VELOCITY_Z,0) = 0.000000; -NODES[17472](VELOCITY_X,0) = 0.000000; -NODES[17472](VELOCITY_Y,0) = 0.000000; -NODES[17472](VELOCITY_Z,0) = 0.000000; -NODES[17479](VELOCITY_X,0) = 0.000000; -NODES[17479](VELOCITY_Y,0) = 0.000000; -NODES[17479](VELOCITY_Z,0) = 0.000000; -NODES[17482](VELOCITY_X,0) = 0.000000; -NODES[17482](VELOCITY_Y,0) = 0.000000; -NODES[17482](VELOCITY_Z,0) = 0.000000; -NODES[17486](VELOCITY_X,0) = 0.000000; -NODES[17486](VELOCITY_Y,0) = 0.000000; -NODES[17486](VELOCITY_Z,0) = 0.000000; -NODES[17487](VELOCITY_X,0) = 0.000000; -NODES[17487](VELOCITY_Y,0) = 0.000000; -NODES[17487](VELOCITY_Z,0) = 0.000000; -NODES[17496](VELOCITY_X,0) = 0.000000; -NODES[17496](VELOCITY_Y,0) = 0.000000; -NODES[17496](VELOCITY_Z,0) = 0.000000; -NODES[17498](VELOCITY_X,0) = 0.000000; -NODES[17498](VELOCITY_Y,0) = 0.000000; -NODES[17498](VELOCITY_Z,0) = 0.000000; -NODES[17502](VELOCITY_X,0) = 0.000000; -NODES[17502](VELOCITY_Y,0) = 0.000000; -NODES[17502](VELOCITY_Z,0) = 0.000000; -NODES[17508](VELOCITY_X,0) = 0.000000; -NODES[17508](VELOCITY_Y,0) = 0.000000; -NODES[17508](VELOCITY_Z,0) = 0.000000; -NODES[17516](VELOCITY_X,0) = 0.000000; -NODES[17516](VELOCITY_Y,0) = 0.000000; -NODES[17516](VELOCITY_Z,0) = 0.000000; -NODES[17518](VELOCITY_X,0) = 0.000000; -NODES[17518](VELOCITY_Y,0) = 0.000000; -NODES[17518](VELOCITY_Z,0) = 0.000000; -NODES[17519](VELOCITY_X,0) = 0.000000; -NODES[17519](VELOCITY_Y,0) = 0.000000; -NODES[17519](VELOCITY_Z,0) = 0.000000; -NODES[17522](VELOCITY_X,0) = 0.000000; -NODES[17522](VELOCITY_Y,0) = 0.000000; -NODES[17522](VELOCITY_Z,0) = 0.000000; -NODES[17525](VELOCITY_X,0) = 0.000000; -NODES[17525](VELOCITY_Y,0) = 0.000000; -NODES[17525](VELOCITY_Z,0) = 0.000000; -NODES[17526](VELOCITY_X,0) = 0.000000; -NODES[17526](VELOCITY_Y,0) = 0.000000; -NODES[17526](VELOCITY_Z,0) = 0.000000; -NODES[17531](VELOCITY_X,0) = 0.000000; -NODES[17531](VELOCITY_Y,0) = 0.000000; -NODES[17531](VELOCITY_Z,0) = 0.000000; -NODES[17538](VELOCITY_X,0) = 0.000000; -NODES[17538](VELOCITY_Y,0) = 0.000000; -NODES[17538](VELOCITY_Z,0) = 0.000000; -NODES[17541](VELOCITY_X,0) = 0.000000; -NODES[17541](VELOCITY_Y,0) = 0.000000; -NODES[17541](VELOCITY_Z,0) = 0.000000; -NODES[17559](VELOCITY_X,0) = 0.000000; -NODES[17559](VELOCITY_Y,0) = 0.000000; -NODES[17559](VELOCITY_Z,0) = 0.000000; -NODES[17561](VELOCITY_X,0) = 0.000000; -NODES[17561](VELOCITY_Y,0) = 0.000000; -NODES[17561](VELOCITY_Z,0) = 0.000000; -NODES[17562](VELOCITY_X,0) = 0.000000; -NODES[17562](VELOCITY_Y,0) = 0.000000; -NODES[17562](VELOCITY_Z,0) = 0.000000; -NODES[17566](VELOCITY_X,0) = 0.000000; -NODES[17566](VELOCITY_Y,0) = 0.000000; -NODES[17566](VELOCITY_Z,0) = 0.000000; -NODES[17567](VELOCITY_X,0) = 0.000000; -NODES[17567](VELOCITY_Y,0) = 0.000000; -NODES[17567](VELOCITY_Z,0) = 0.000000; -NODES[17577](VELOCITY_X,0) = 0.000000; -NODES[17577](VELOCITY_Y,0) = 0.000000; -NODES[17577](VELOCITY_Z,0) = 0.000000; -NODES[17579](VELOCITY_X,0) = 0.000000; -NODES[17579](VELOCITY_Y,0) = 0.000000; -NODES[17579](VELOCITY_Z,0) = 0.000000; -NODES[17583](VELOCITY_X,0) = 0.000000; -NODES[17583](VELOCITY_Y,0) = 0.000000; -NODES[17583](VELOCITY_Z,0) = 0.000000; -NODES[17584](VELOCITY_X,0) = 0.000000; -NODES[17584](VELOCITY_Y,0) = 0.000000; -NODES[17584](VELOCITY_Z,0) = 0.000000; -NODES[17585](VELOCITY_X,0) = 0.000000; -NODES[17585](VELOCITY_Y,0) = 0.000000; -NODES[17585](VELOCITY_Z,0) = 0.000000; -NODES[17606](VELOCITY_X,0) = 0.000000; -NODES[17606](VELOCITY_Y,0) = 0.000000; -NODES[17606](VELOCITY_Z,0) = 0.000000; -NODES[17611](VELOCITY_X,0) = 0.000000; -NODES[17611](VELOCITY_Y,0) = 0.000000; -NODES[17611](VELOCITY_Z,0) = 0.000000; -NODES[17617](VELOCITY_X,0) = 0.000000; -NODES[17617](VELOCITY_Y,0) = 0.000000; -NODES[17617](VELOCITY_Z,0) = 0.000000; -NODES[17621](VELOCITY_X,0) = 0.000000; -NODES[17621](VELOCITY_Y,0) = 0.000000; -NODES[17621](VELOCITY_Z,0) = 0.000000; -NODES[17628](VELOCITY_X,0) = 0.000000; -NODES[17628](VELOCITY_Y,0) = 0.000000; -NODES[17628](VELOCITY_Z,0) = 0.000000; -NODES[17630](VELOCITY_X,0) = 0.000000; -NODES[17630](VELOCITY_Y,0) = 0.000000; -NODES[17630](VELOCITY_Z,0) = 0.000000; -NODES[17632](VELOCITY_X,0) = 0.000000; -NODES[17632](VELOCITY_Y,0) = 0.000000; -NODES[17632](VELOCITY_Z,0) = 0.000000; -NODES[17639](VELOCITY_X,0) = 0.000000; -NODES[17639](VELOCITY_Y,0) = 0.000000; -NODES[17639](VELOCITY_Z,0) = 0.000000; -NODES[17642](VELOCITY_X,0) = 0.000000; -NODES[17642](VELOCITY_Y,0) = 0.000000; -NODES[17642](VELOCITY_Z,0) = 0.000000; -NODES[17651](VELOCITY_X,0) = 0.000000; -NODES[17651](VELOCITY_Y,0) = 0.000000; -NODES[17651](VELOCITY_Z,0) = 0.000000; -NODES[17654](VELOCITY_X,0) = 0.000000; -NODES[17654](VELOCITY_Y,0) = 0.000000; -NODES[17654](VELOCITY_Z,0) = 0.000000; -NODES[17655](VELOCITY_X,0) = 0.000000; -NODES[17655](VELOCITY_Y,0) = 0.000000; -NODES[17655](VELOCITY_Z,0) = 0.000000; -NODES[17661](VELOCITY_X,0) = 0.000000; -NODES[17661](VELOCITY_Y,0) = 0.000000; -NODES[17661](VELOCITY_Z,0) = 0.000000; -NODES[17665](VELOCITY_X,0) = 0.000000; -NODES[17665](VELOCITY_Y,0) = 0.000000; -NODES[17665](VELOCITY_Z,0) = 0.000000; -NODES[17668](VELOCITY_X,0) = 0.000000; -NODES[17668](VELOCITY_Y,0) = 0.000000; -NODES[17668](VELOCITY_Z,0) = 0.000000; -NODES[17669](VELOCITY_X,0) = 0.000000; -NODES[17669](VELOCITY_Y,0) = 0.000000; -NODES[17669](VELOCITY_Z,0) = 0.000000; -NODES[17675](VELOCITY_X,0) = 0.000000; -NODES[17675](VELOCITY_Y,0) = 0.000000; -NODES[17675](VELOCITY_Z,0) = 0.000000; -NODES[17680](VELOCITY_X,0) = 0.000000; -NODES[17680](VELOCITY_Y,0) = 0.000000; -NODES[17680](VELOCITY_Z,0) = 0.000000; -NODES[17681](VELOCITY_X,0) = 0.000000; -NODES[17681](VELOCITY_Y,0) = 0.000000; -NODES[17681](VELOCITY_Z,0) = 0.000000; -NODES[17684](VELOCITY_X,0) = 0.000000; -NODES[17684](VELOCITY_Y,0) = 0.000000; -NODES[17684](VELOCITY_Z,0) = 0.000000; -NODES[17685](VELOCITY_X,0) = 0.000000; -NODES[17685](VELOCITY_Y,0) = 0.000000; -NODES[17685](VELOCITY_Z,0) = 0.000000; -NODES[17686](VELOCITY_X,0) = 0.000000; -NODES[17686](VELOCITY_Y,0) = 0.000000; -NODES[17686](VELOCITY_Z,0) = 0.000000; -NODES[17690](VELOCITY_X,0) = 0.000000; -NODES[17690](VELOCITY_Y,0) = 0.000000; -NODES[17690](VELOCITY_Z,0) = 0.000000; -NODES[17695](VELOCITY_X,0) = 0.000000; -NODES[17695](VELOCITY_Y,0) = 0.000000; -NODES[17695](VELOCITY_Z,0) = 0.000000; -NODES[17696](VELOCITY_X,0) = 0.000000; -NODES[17696](VELOCITY_Y,0) = 0.000000; -NODES[17696](VELOCITY_Z,0) = 0.000000; -NODES[17698](VELOCITY_X,0) = 0.000000; -NODES[17698](VELOCITY_Y,0) = 0.000000; -NODES[17698](VELOCITY_Z,0) = 0.000000; -NODES[17713](VELOCITY_X,0) = 0.000000; -NODES[17713](VELOCITY_Y,0) = 0.000000; -NODES[17713](VELOCITY_Z,0) = 0.000000; -NODES[17717](VELOCITY_X,0) = 0.000000; -NODES[17717](VELOCITY_Y,0) = 0.000000; -NODES[17717](VELOCITY_Z,0) = 0.000000; -NODES[17718](VELOCITY_X,0) = 0.000000; -NODES[17718](VELOCITY_Y,0) = 0.000000; -NODES[17718](VELOCITY_Z,0) = 0.000000; -NODES[17723](VELOCITY_X,0) = 0.000000; -NODES[17723](VELOCITY_Y,0) = 0.000000; -NODES[17723](VELOCITY_Z,0) = 0.000000; -NODES[17726](VELOCITY_X,0) = 0.000000; -NODES[17726](VELOCITY_Y,0) = 0.000000; -NODES[17726](VELOCITY_Z,0) = 0.000000; -NODES[17729](VELOCITY_X,0) = 0.000000; -NODES[17729](VELOCITY_Y,0) = 0.000000; -NODES[17729](VELOCITY_Z,0) = 0.000000; -NODES[17735](VELOCITY_X,0) = 0.000000; -NODES[17735](VELOCITY_Y,0) = 0.000000; -NODES[17735](VELOCITY_Z,0) = 0.000000; -NODES[17736](VELOCITY_X,0) = 0.000000; -NODES[17736](VELOCITY_Y,0) = 0.000000; -NODES[17736](VELOCITY_Z,0) = 0.000000; -NODES[17742](VELOCITY_X,0) = 0.000000; -NODES[17742](VELOCITY_Y,0) = 0.000000; -NODES[17742](VELOCITY_Z,0) = 0.000000; -NODES[17745](VELOCITY_X,0) = 0.000000; -NODES[17745](VELOCITY_Y,0) = 0.000000; -NODES[17745](VELOCITY_Z,0) = 0.000000; -NODES[17757](VELOCITY_X,0) = 0.000000; -NODES[17757](VELOCITY_Y,0) = 0.000000; -NODES[17757](VELOCITY_Z,0) = 0.000000; -NODES[17761](VELOCITY_X,0) = 0.000000; -NODES[17761](VELOCITY_Y,0) = 0.000000; -NODES[17761](VELOCITY_Z,0) = 0.000000; -NODES[17762](VELOCITY_X,0) = 0.000000; -NODES[17762](VELOCITY_Y,0) = 0.000000; -NODES[17762](VELOCITY_Z,0) = 0.000000; -NODES[17763](VELOCITY_X,0) = 0.000000; -NODES[17763](VELOCITY_Y,0) = 0.000000; -NODES[17763](VELOCITY_Z,0) = 0.000000; -NODES[17765](VELOCITY_X,0) = 0.000000; -NODES[17765](VELOCITY_Y,0) = 0.000000; -NODES[17765](VELOCITY_Z,0) = 0.000000; -NODES[17766](VELOCITY_X,0) = 0.000000; -NODES[17766](VELOCITY_Y,0) = 0.000000; -NODES[17766](VELOCITY_Z,0) = 0.000000; -NODES[17771](VELOCITY_X,0) = 0.000000; -NODES[17771](VELOCITY_Y,0) = 0.000000; -NODES[17771](VELOCITY_Z,0) = 0.000000; -NODES[17774](VELOCITY_X,0) = 0.000000; -NODES[17774](VELOCITY_Y,0) = 0.000000; -NODES[17774](VELOCITY_Z,0) = 0.000000; -NODES[17776](VELOCITY_X,0) = 0.000000; -NODES[17776](VELOCITY_Y,0) = 0.000000; -NODES[17776](VELOCITY_Z,0) = 0.000000; -NODES[17781](VELOCITY_X,0) = 0.000000; -NODES[17781](VELOCITY_Y,0) = 0.000000; -NODES[17781](VELOCITY_Z,0) = 0.000000; -NODES[17797](VELOCITY_X,0) = 0.000000; -NODES[17797](VELOCITY_Y,0) = 0.000000; -NODES[17797](VELOCITY_Z,0) = 0.000000; -NODES[17807](VELOCITY_X,0) = 0.000000; -NODES[17807](VELOCITY_Y,0) = 0.000000; -NODES[17807](VELOCITY_Z,0) = 0.000000; -NODES[17816](VELOCITY_X,0) = 0.000000; -NODES[17816](VELOCITY_Y,0) = 0.000000; -NODES[17816](VELOCITY_Z,0) = 0.000000; -NODES[17817](VELOCITY_X,0) = 0.000000; -NODES[17817](VELOCITY_Y,0) = 0.000000; -NODES[17817](VELOCITY_Z,0) = 0.000000; -NODES[17819](VELOCITY_X,0) = 0.000000; -NODES[17819](VELOCITY_Y,0) = 0.000000; -NODES[17819](VELOCITY_Z,0) = 0.000000; -NODES[17820](VELOCITY_X,0) = 0.000000; -NODES[17820](VELOCITY_Y,0) = 0.000000; -NODES[17820](VELOCITY_Z,0) = 0.000000; -NODES[17829](VELOCITY_X,0) = 0.000000; -NODES[17829](VELOCITY_Y,0) = 0.000000; -NODES[17829](VELOCITY_Z,0) = 0.000000; -NODES[17831](VELOCITY_X,0) = 0.000000; -NODES[17831](VELOCITY_Y,0) = 0.000000; -NODES[17831](VELOCITY_Z,0) = 0.000000; -NODES[17837](VELOCITY_X,0) = 0.000000; -NODES[17837](VELOCITY_Y,0) = 0.000000; -NODES[17837](VELOCITY_Z,0) = 0.000000; -NODES[17846](VELOCITY_X,0) = 0.000000; -NODES[17846](VELOCITY_Y,0) = 0.000000; -NODES[17846](VELOCITY_Z,0) = 0.000000; -NODES[17847](VELOCITY_X,0) = 0.000000; -NODES[17847](VELOCITY_Y,0) = 0.000000; -NODES[17847](VELOCITY_Z,0) = 0.000000; -NODES[17849](VELOCITY_X,0) = 0.000000; -NODES[17849](VELOCITY_Y,0) = 0.000000; -NODES[17849](VELOCITY_Z,0) = 0.000000; -NODES[17861](VELOCITY_X,0) = 0.000000; -NODES[17861](VELOCITY_Y,0) = 0.000000; -NODES[17861](VELOCITY_Z,0) = 0.000000; -NODES[17862](VELOCITY_X,0) = 0.000000; -NODES[17862](VELOCITY_Y,0) = 0.000000; -NODES[17862](VELOCITY_Z,0) = 0.000000; -NODES[17864](VELOCITY_X,0) = 0.000000; -NODES[17864](VELOCITY_Y,0) = 0.000000; -NODES[17864](VELOCITY_Z,0) = 0.000000; -NODES[17866](VELOCITY_X,0) = 0.000000; -NODES[17866](VELOCITY_Y,0) = 0.000000; -NODES[17866](VELOCITY_Z,0) = 0.000000; -NODES[17869](VELOCITY_X,0) = 0.000000; -NODES[17869](VELOCITY_Y,0) = 0.000000; -NODES[17869](VELOCITY_Z,0) = 0.000000; -NODES[17870](VELOCITY_X,0) = 0.000000; -NODES[17870](VELOCITY_Y,0) = 0.000000; -NODES[17870](VELOCITY_Z,0) = 0.000000; -NODES[17871](VELOCITY_X,0) = 0.000000; -NODES[17871](VELOCITY_Y,0) = 0.000000; -NODES[17871](VELOCITY_Z,0) = 0.000000; -NODES[17878](VELOCITY_X,0) = 0.000000; -NODES[17878](VELOCITY_Y,0) = 0.000000; -NODES[17878](VELOCITY_Z,0) = 0.000000; -NODES[17880](VELOCITY_X,0) = 0.000000; -NODES[17880](VELOCITY_Y,0) = 0.000000; -NODES[17880](VELOCITY_Z,0) = 0.000000; -NODES[17881](VELOCITY_X,0) = 0.000000; -NODES[17881](VELOCITY_Y,0) = 0.000000; -NODES[17881](VELOCITY_Z,0) = 0.000000; -NODES[17883](VELOCITY_X,0) = 0.000000; -NODES[17883](VELOCITY_Y,0) = 0.000000; -NODES[17883](VELOCITY_Z,0) = 0.000000; -NODES[17886](VELOCITY_X,0) = 0.000000; -NODES[17886](VELOCITY_Y,0) = 0.000000; -NODES[17886](VELOCITY_Z,0) = 0.000000; -NODES[17888](VELOCITY_X,0) = 0.000000; -NODES[17888](VELOCITY_Y,0) = 0.000000; -NODES[17888](VELOCITY_Z,0) = 0.000000; -NODES[17893](VELOCITY_X,0) = 0.000000; -NODES[17893](VELOCITY_Y,0) = 0.000000; -NODES[17893](VELOCITY_Z,0) = 0.000000; -NODES[17898](VELOCITY_X,0) = 0.000000; -NODES[17898](VELOCITY_Y,0) = 0.000000; -NODES[17898](VELOCITY_Z,0) = 0.000000; -NODES[17906](VELOCITY_X,0) = 0.000000; -NODES[17906](VELOCITY_Y,0) = 0.000000; -NODES[17906](VELOCITY_Z,0) = 0.000000; -NODES[17907](VELOCITY_X,0) = 0.000000; -NODES[17907](VELOCITY_Y,0) = 0.000000; -NODES[17907](VELOCITY_Z,0) = 0.000000; -NODES[17910](VELOCITY_X,0) = 0.000000; -NODES[17910](VELOCITY_Y,0) = 0.000000; -NODES[17910](VELOCITY_Z,0) = 0.000000; -NODES[17914](VELOCITY_X,0) = 0.000000; -NODES[17914](VELOCITY_Y,0) = 0.000000; -NODES[17914](VELOCITY_Z,0) = 0.000000; -NODES[17915](VELOCITY_X,0) = 0.000000; -NODES[17915](VELOCITY_Y,0) = 0.000000; -NODES[17915](VELOCITY_Z,0) = 0.000000; -NODES[17916](VELOCITY_X,0) = 0.000000; -NODES[17916](VELOCITY_Y,0) = 0.000000; -NODES[17916](VELOCITY_Z,0) = 0.000000; -NODES[17918](VELOCITY_X,0) = 0.000000; -NODES[17918](VELOCITY_Y,0) = 0.000000; -NODES[17918](VELOCITY_Z,0) = 0.000000; -NODES[17923](VELOCITY_X,0) = 0.000000; -NODES[17923](VELOCITY_Y,0) = 0.000000; -NODES[17923](VELOCITY_Z,0) = 0.000000; -NODES[17926](VELOCITY_X,0) = 0.000000; -NODES[17926](VELOCITY_Y,0) = 0.000000; -NODES[17926](VELOCITY_Z,0) = 0.000000; -NODES[17927](VELOCITY_X,0) = 0.000000; -NODES[17927](VELOCITY_Y,0) = 0.000000; -NODES[17927](VELOCITY_Z,0) = 0.000000; -NODES[17928](VELOCITY_X,0) = 0.000000; -NODES[17928](VELOCITY_Y,0) = 0.000000; -NODES[17928](VELOCITY_Z,0) = 0.000000; -NODES[17937](VELOCITY_X,0) = 0.000000; -NODES[17937](VELOCITY_Y,0) = 0.000000; -NODES[17937](VELOCITY_Z,0) = 0.000000; -NODES[17941](VELOCITY_X,0) = 0.000000; -NODES[17941](VELOCITY_Y,0) = 0.000000; -NODES[17941](VELOCITY_Z,0) = 0.000000; -NODES[17942](VELOCITY_X,0) = 0.000000; -NODES[17942](VELOCITY_Y,0) = 0.000000; -NODES[17942](VELOCITY_Z,0) = 0.000000; -NODES[17953](VELOCITY_X,0) = 0.000000; -NODES[17953](VELOCITY_Y,0) = 0.000000; -NODES[17953](VELOCITY_Z,0) = 0.000000; -NODES[17954](VELOCITY_X,0) = 0.000000; -NODES[17954](VELOCITY_Y,0) = 0.000000; -NODES[17954](VELOCITY_Z,0) = 0.000000; -NODES[17962](VELOCITY_X,0) = 0.000000; -NODES[17962](VELOCITY_Y,0) = 0.000000; -NODES[17962](VELOCITY_Z,0) = 0.000000; -NODES[17968](VELOCITY_X,0) = 0.000000; -NODES[17968](VELOCITY_Y,0) = 0.000000; -NODES[17968](VELOCITY_Z,0) = 0.000000; -NODES[17973](VELOCITY_X,0) = 0.000000; -NODES[17973](VELOCITY_Y,0) = 0.000000; -NODES[17973](VELOCITY_Z,0) = 0.000000; -NODES[17976](VELOCITY_X,0) = 0.000000; -NODES[17976](VELOCITY_Y,0) = 0.000000; -NODES[17976](VELOCITY_Z,0) = 0.000000; -NODES[17984](VELOCITY_X,0) = 0.000000; -NODES[17984](VELOCITY_Y,0) = 0.000000; -NODES[17984](VELOCITY_Z,0) = 0.000000; -NODES[17985](VELOCITY_X,0) = 0.000000; -NODES[17985](VELOCITY_Y,0) = 0.000000; -NODES[17985](VELOCITY_Z,0) = 0.000000; -NODES[17988](VELOCITY_X,0) = 0.000000; -NODES[17988](VELOCITY_Y,0) = 0.000000; -NODES[17988](VELOCITY_Z,0) = 0.000000; -NODES[17989](VELOCITY_X,0) = 0.000000; -NODES[17989](VELOCITY_Y,0) = 0.000000; -NODES[17989](VELOCITY_Z,0) = 0.000000; -NODES[17990](VELOCITY_X,0) = 0.000000; -NODES[17990](VELOCITY_Y,0) = 0.000000; -NODES[17990](VELOCITY_Z,0) = 0.000000; -NODES[17991](VELOCITY_X,0) = 0.000000; -NODES[17991](VELOCITY_Y,0) = 0.000000; -NODES[17991](VELOCITY_Z,0) = 0.000000; -NODES[17997](VELOCITY_X,0) = 0.000000; -NODES[17997](VELOCITY_Y,0) = 0.000000; -NODES[17997](VELOCITY_Z,0) = 0.000000; -NODES[18000](VELOCITY_X,0) = 0.000000; -NODES[18000](VELOCITY_Y,0) = 0.000000; -NODES[18000](VELOCITY_Z,0) = 0.000000; -NODES[18002](VELOCITY_X,0) = 0.000000; -NODES[18002](VELOCITY_Y,0) = 0.000000; -NODES[18002](VELOCITY_Z,0) = 0.000000; -NODES[18006](VELOCITY_X,0) = 0.000000; -NODES[18006](VELOCITY_Y,0) = 0.000000; -NODES[18006](VELOCITY_Z,0) = 0.000000; -NODES[18027](VELOCITY_X,0) = 0.000000; -NODES[18027](VELOCITY_Y,0) = 0.000000; -NODES[18027](VELOCITY_Z,0) = 0.000000; -NODES[18028](VELOCITY_X,0) = 0.000000; -NODES[18028](VELOCITY_Y,0) = 0.000000; -NODES[18028](VELOCITY_Z,0) = 0.000000; -NODES[18030](VELOCITY_X,0) = 0.000000; -NODES[18030](VELOCITY_Y,0) = 0.000000; -NODES[18030](VELOCITY_Z,0) = 0.000000; -NODES[18032](VELOCITY_X,0) = 0.000000; -NODES[18032](VELOCITY_Y,0) = 0.000000; -NODES[18032](VELOCITY_Z,0) = 0.000000; -NODES[18033](VELOCITY_X,0) = 0.000000; -NODES[18033](VELOCITY_Y,0) = 0.000000; -NODES[18033](VELOCITY_Z,0) = 0.000000; -NODES[18040](VELOCITY_X,0) = 0.000000; -NODES[18040](VELOCITY_Y,0) = 0.000000; -NODES[18040](VELOCITY_Z,0) = 0.000000; -NODES[18043](VELOCITY_X,0) = 0.000000; -NODES[18043](VELOCITY_Y,0) = 0.000000; -NODES[18043](VELOCITY_Z,0) = 0.000000; -NODES[18046](VELOCITY_X,0) = 0.000000; -NODES[18046](VELOCITY_Y,0) = 0.000000; -NODES[18046](VELOCITY_Z,0) = 0.000000; -NODES[18052](VELOCITY_X,0) = 0.000000; -NODES[18052](VELOCITY_Y,0) = 0.000000; -NODES[18052](VELOCITY_Z,0) = 0.000000; -NODES[18053](VELOCITY_X,0) = 0.000000; -NODES[18053](VELOCITY_Y,0) = 0.000000; -NODES[18053](VELOCITY_Z,0) = 0.000000; -NODES[18059](VELOCITY_X,0) = 0.000000; -NODES[18059](VELOCITY_Y,0) = 0.000000; -NODES[18059](VELOCITY_Z,0) = 0.000000; -NODES[18064](VELOCITY_X,0) = 0.000000; -NODES[18064](VELOCITY_Y,0) = 0.000000; -NODES[18064](VELOCITY_Z,0) = 0.000000; -NODES[18066](VELOCITY_X,0) = 0.000000; -NODES[18066](VELOCITY_Y,0) = 0.000000; -NODES[18066](VELOCITY_Z,0) = 0.000000; -NODES[18068](VELOCITY_X,0) = 0.000000; -NODES[18068](VELOCITY_Y,0) = 0.000000; -NODES[18068](VELOCITY_Z,0) = 0.000000; -NODES[18070](VELOCITY_X,0) = 0.000000; -NODES[18070](VELOCITY_Y,0) = 0.000000; -NODES[18070](VELOCITY_Z,0) = 0.000000; -NODES[18071](VELOCITY_X,0) = 0.000000; -NODES[18071](VELOCITY_Y,0) = 0.000000; -NODES[18071](VELOCITY_Z,0) = 0.000000; -NODES[18073](VELOCITY_X,0) = 0.000000; -NODES[18073](VELOCITY_Y,0) = 0.000000; -NODES[18073](VELOCITY_Z,0) = 0.000000; -NODES[18080](VELOCITY_X,0) = 0.000000; -NODES[18080](VELOCITY_Y,0) = 0.000000; -NODES[18080](VELOCITY_Z,0) = 0.000000; -NODES[18083](VELOCITY_X,0) = 0.000000; -NODES[18083](VELOCITY_Y,0) = 0.000000; -NODES[18083](VELOCITY_Z,0) = 0.000000; -NODES[18084](VELOCITY_X,0) = 0.000000; -NODES[18084](VELOCITY_Y,0) = 0.000000; -NODES[18084](VELOCITY_Z,0) = 0.000000; -NODES[18085](VELOCITY_X,0) = 0.000000; -NODES[18085](VELOCITY_Y,0) = 0.000000; -NODES[18085](VELOCITY_Z,0) = 0.000000; -NODES[18086](VELOCITY_X,0) = 0.000000; -NODES[18086](VELOCITY_Y,0) = 0.000000; -NODES[18086](VELOCITY_Z,0) = 0.000000; -NODES[18089](VELOCITY_X,0) = 0.000000; -NODES[18089](VELOCITY_Y,0) = 0.000000; -NODES[18089](VELOCITY_Z,0) = 0.000000; -NODES[18095](VELOCITY_X,0) = 0.000000; -NODES[18095](VELOCITY_Y,0) = 0.000000; -NODES[18095](VELOCITY_Z,0) = 0.000000; -NODES[18105](VELOCITY_X,0) = 0.000000; -NODES[18105](VELOCITY_Y,0) = 0.000000; -NODES[18105](VELOCITY_Z,0) = 0.000000; -NODES[18106](VELOCITY_X,0) = 0.000000; -NODES[18106](VELOCITY_Y,0) = 0.000000; -NODES[18106](VELOCITY_Z,0) = 0.000000; -NODES[18113](VELOCITY_X,0) = 0.000000; -NODES[18113](VELOCITY_Y,0) = 0.000000; -NODES[18113](VELOCITY_Z,0) = 0.000000; -NODES[18115](VELOCITY_X,0) = 0.000000; -NODES[18115](VELOCITY_Y,0) = 0.000000; -NODES[18115](VELOCITY_Z,0) = 0.000000; -NODES[18116](VELOCITY_X,0) = 0.000000; -NODES[18116](VELOCITY_Y,0) = 0.000000; -NODES[18116](VELOCITY_Z,0) = 0.000000; -NODES[18118](VELOCITY_X,0) = 0.000000; -NODES[18118](VELOCITY_Y,0) = 0.000000; -NODES[18118](VELOCITY_Z,0) = 0.000000; -NODES[18119](VELOCITY_X,0) = 0.000000; -NODES[18119](VELOCITY_Y,0) = 0.000000; -NODES[18119](VELOCITY_Z,0) = 0.000000; -NODES[18120](VELOCITY_X,0) = 0.000000; -NODES[18120](VELOCITY_Y,0) = 0.000000; -NODES[18120](VELOCITY_Z,0) = 0.000000; -NODES[18121](VELOCITY_X,0) = 0.000000; -NODES[18121](VELOCITY_Y,0) = 0.000000; -NODES[18121](VELOCITY_Z,0) = 0.000000; -NODES[18125](VELOCITY_X,0) = 0.000000; -NODES[18125](VELOCITY_Y,0) = 0.000000; -NODES[18125](VELOCITY_Z,0) = 0.000000; -NODES[18126](VELOCITY_X,0) = 0.000000; -NODES[18126](VELOCITY_Y,0) = 0.000000; -NODES[18126](VELOCITY_Z,0) = 0.000000; -NODES[18136](VELOCITY_X,0) = 0.000000; -NODES[18136](VELOCITY_Y,0) = 0.000000; -NODES[18136](VELOCITY_Z,0) = 0.000000; -NODES[18141](VELOCITY_X,0) = 0.000000; -NODES[18141](VELOCITY_Y,0) = 0.000000; -NODES[18141](VELOCITY_Z,0) = 0.000000; -NODES[18142](VELOCITY_X,0) = 0.000000; -NODES[18142](VELOCITY_Y,0) = 0.000000; -NODES[18142](VELOCITY_Z,0) = 0.000000; -NODES[18145](VELOCITY_X,0) = 0.000000; -NODES[18145](VELOCITY_Y,0) = 0.000000; -NODES[18145](VELOCITY_Z,0) = 0.000000; -NODES[18147](VELOCITY_X,0) = 0.000000; -NODES[18147](VELOCITY_Y,0) = 0.000000; -NODES[18147](VELOCITY_Z,0) = 0.000000; -NODES[18149](VELOCITY_X,0) = 0.000000; -NODES[18149](VELOCITY_Y,0) = 0.000000; -NODES[18149](VELOCITY_Z,0) = 0.000000; -NODES[18150](VELOCITY_X,0) = 0.000000; -NODES[18150](VELOCITY_Y,0) = 0.000000; -NODES[18150](VELOCITY_Z,0) = 0.000000; -NODES[18162](VELOCITY_X,0) = 0.000000; -NODES[18162](VELOCITY_Y,0) = 0.000000; -NODES[18162](VELOCITY_Z,0) = 0.000000; -NODES[18163](VELOCITY_X,0) = 0.000000; -NODES[18163](VELOCITY_Y,0) = 0.000000; -NODES[18163](VELOCITY_Z,0) = 0.000000; -NODES[18164](VELOCITY_X,0) = 0.000000; -NODES[18164](VELOCITY_Y,0) = 0.000000; -NODES[18164](VELOCITY_Z,0) = 0.000000; -NODES[18167](VELOCITY_X,0) = 0.000000; -NODES[18167](VELOCITY_Y,0) = 0.000000; -NODES[18167](VELOCITY_Z,0) = 0.000000; -NODES[18168](VELOCITY_X,0) = 0.000000; -NODES[18168](VELOCITY_Y,0) = 0.000000; -NODES[18168](VELOCITY_Z,0) = 0.000000; -NODES[18170](VELOCITY_X,0) = 0.000000; -NODES[18170](VELOCITY_Y,0) = 0.000000; -NODES[18170](VELOCITY_Z,0) = 0.000000; -NODES[18175](VELOCITY_X,0) = 0.000000; -NODES[18175](VELOCITY_Y,0) = 0.000000; -NODES[18175](VELOCITY_Z,0) = 0.000000; -NODES[18180](VELOCITY_X,0) = 0.000000; -NODES[18180](VELOCITY_Y,0) = 0.000000; -NODES[18180](VELOCITY_Z,0) = 0.000000; -NODES[18181](VELOCITY_X,0) = 0.000000; -NODES[18181](VELOCITY_Y,0) = 0.000000; -NODES[18181](VELOCITY_Z,0) = 0.000000; -NODES[18184](VELOCITY_X,0) = 0.000000; -NODES[18184](VELOCITY_Y,0) = 0.000000; -NODES[18184](VELOCITY_Z,0) = 0.000000; -NODES[18186](VELOCITY_X,0) = 0.000000; -NODES[18186](VELOCITY_Y,0) = 0.000000; -NODES[18186](VELOCITY_Z,0) = 0.000000; -NODES[18190](VELOCITY_X,0) = 0.000000; -NODES[18190](VELOCITY_Y,0) = 0.000000; -NODES[18190](VELOCITY_Z,0) = 0.000000; -NODES[18193](VELOCITY_X,0) = 0.000000; -NODES[18193](VELOCITY_Y,0) = 0.000000; -NODES[18193](VELOCITY_Z,0) = 0.000000; -NODES[18197](VELOCITY_X,0) = 0.000000; -NODES[18197](VELOCITY_Y,0) = 0.000000; -NODES[18197](VELOCITY_Z,0) = 0.000000; -NODES[18199](VELOCITY_X,0) = 0.000000; -NODES[18199](VELOCITY_Y,0) = 0.000000; -NODES[18199](VELOCITY_Z,0) = 0.000000; -NODES[18203](VELOCITY_X,0) = 0.000000; -NODES[18203](VELOCITY_Y,0) = 0.000000; -NODES[18203](VELOCITY_Z,0) = 0.000000; -NODES[18209](VELOCITY_X,0) = 0.000000; -NODES[18209](VELOCITY_Y,0) = 0.000000; -NODES[18209](VELOCITY_Z,0) = 0.000000; -NODES[18214](VELOCITY_X,0) = 0.000000; -NODES[18214](VELOCITY_Y,0) = 0.000000; -NODES[18214](VELOCITY_Z,0) = 0.000000; -NODES[18217](VELOCITY_X,0) = 0.000000; -NODES[18217](VELOCITY_Y,0) = 0.000000; -NODES[18217](VELOCITY_Z,0) = 0.000000; -NODES[18218](VELOCITY_X,0) = 0.000000; -NODES[18218](VELOCITY_Y,0) = 0.000000; -NODES[18218](VELOCITY_Z,0) = 0.000000; -NODES[18221](VELOCITY_X,0) = 0.000000; -NODES[18221](VELOCITY_Y,0) = 0.000000; -NODES[18221](VELOCITY_Z,0) = 0.000000; -NODES[18225](VELOCITY_X,0) = 0.000000; -NODES[18225](VELOCITY_Y,0) = 0.000000; -NODES[18225](VELOCITY_Z,0) = 0.000000; -NODES[18227](VELOCITY_X,0) = 0.000000; -NODES[18227](VELOCITY_Y,0) = 0.000000; -NODES[18227](VELOCITY_Z,0) = 0.000000; -NODES[18233](VELOCITY_X,0) = 0.000000; -NODES[18233](VELOCITY_Y,0) = 0.000000; -NODES[18233](VELOCITY_Z,0) = 0.000000; -NODES[18236](VELOCITY_X,0) = 0.000000; -NODES[18236](VELOCITY_Y,0) = 0.000000; -NODES[18236](VELOCITY_Z,0) = 0.000000; -NODES[18242](VELOCITY_X,0) = 0.000000; -NODES[18242](VELOCITY_Y,0) = 0.000000; -NODES[18242](VELOCITY_Z,0) = 0.000000; -NODES[18245](VELOCITY_X,0) = 0.000000; -NODES[18245](VELOCITY_Y,0) = 0.000000; -NODES[18245](VELOCITY_Z,0) = 0.000000; -NODES[18247](VELOCITY_X,0) = 0.000000; -NODES[18247](VELOCITY_Y,0) = 0.000000; -NODES[18247](VELOCITY_Z,0) = 0.000000; -NODES[18251](VELOCITY_X,0) = 0.000000; -NODES[18251](VELOCITY_Y,0) = 0.000000; -NODES[18251](VELOCITY_Z,0) = 0.000000; -NODES[18255](VELOCITY_X,0) = 0.000000; -NODES[18255](VELOCITY_Y,0) = 0.000000; -NODES[18255](VELOCITY_Z,0) = 0.000000; -NODES[18256](VELOCITY_X,0) = 0.000000; -NODES[18256](VELOCITY_Y,0) = 0.000000; -NODES[18256](VELOCITY_Z,0) = 0.000000; -NODES[18259](VELOCITY_X,0) = 0.000000; -NODES[18259](VELOCITY_Y,0) = 0.000000; -NODES[18259](VELOCITY_Z,0) = 0.000000; -NODES[18260](VELOCITY_X,0) = 0.000000; -NODES[18260](VELOCITY_Y,0) = 0.000000; -NODES[18260](VELOCITY_Z,0) = 0.000000; -NODES[18261](VELOCITY_X,0) = 0.000000; -NODES[18261](VELOCITY_Y,0) = 0.000000; -NODES[18261](VELOCITY_Z,0) = 0.000000; -NODES[18265](VELOCITY_X,0) = 0.000000; -NODES[18265](VELOCITY_Y,0) = 0.000000; -NODES[18265](VELOCITY_Z,0) = 0.000000; -NODES[18266](VELOCITY_X,0) = 0.000000; -NODES[18266](VELOCITY_Y,0) = 0.000000; -NODES[18266](VELOCITY_Z,0) = 0.000000; -NODES[18272](VELOCITY_X,0) = 0.000000; -NODES[18272](VELOCITY_Y,0) = 0.000000; -NODES[18272](VELOCITY_Z,0) = 0.000000; -NODES[18273](VELOCITY_X,0) = 0.000000; -NODES[18273](VELOCITY_Y,0) = 0.000000; -NODES[18273](VELOCITY_Z,0) = 0.000000; -NODES[18274](VELOCITY_X,0) = 0.000000; -NODES[18274](VELOCITY_Y,0) = 0.000000; -NODES[18274](VELOCITY_Z,0) = 0.000000; -NODES[18284](VELOCITY_X,0) = 0.000000; -NODES[18284](VELOCITY_Y,0) = 0.000000; -NODES[18284](VELOCITY_Z,0) = 0.000000; -NODES[18285](VELOCITY_X,0) = 0.000000; -NODES[18285](VELOCITY_Y,0) = 0.000000; -NODES[18285](VELOCITY_Z,0) = 0.000000; -NODES[18286](VELOCITY_X,0) = 0.000000; -NODES[18286](VELOCITY_Y,0) = 0.000000; -NODES[18286](VELOCITY_Z,0) = 0.000000; -NODES[18291](VELOCITY_X,0) = 0.000000; -NODES[18291](VELOCITY_Y,0) = 0.000000; -NODES[18291](VELOCITY_Z,0) = 0.000000; -NODES[18300](VELOCITY_X,0) = 0.000000; -NODES[18300](VELOCITY_Y,0) = 0.000000; -NODES[18300](VELOCITY_Z,0) = 0.000000; -NODES[18301](VELOCITY_X,0) = 0.000000; -NODES[18301](VELOCITY_Y,0) = 0.000000; -NODES[18301](VELOCITY_Z,0) = 0.000000; -NODES[18303](VELOCITY_X,0) = 0.000000; -NODES[18303](VELOCITY_Y,0) = 0.000000; -NODES[18303](VELOCITY_Z,0) = 0.000000; -NODES[18304](VELOCITY_X,0) = 0.000000; -NODES[18304](VELOCITY_Y,0) = 0.000000; -NODES[18304](VELOCITY_Z,0) = 0.000000; -NODES[18306](VELOCITY_X,0) = 0.000000; -NODES[18306](VELOCITY_Y,0) = 0.000000; -NODES[18306](VELOCITY_Z,0) = 0.000000; -NODES[18312](VELOCITY_X,0) = 0.000000; -NODES[18312](VELOCITY_Y,0) = 0.000000; -NODES[18312](VELOCITY_Z,0) = 0.000000; -NODES[18316](VELOCITY_X,0) = 0.000000; -NODES[18316](VELOCITY_Y,0) = 0.000000; -NODES[18316](VELOCITY_Z,0) = 0.000000; -NODES[18317](VELOCITY_X,0) = 0.000000; -NODES[18317](VELOCITY_Y,0) = 0.000000; -NODES[18317](VELOCITY_Z,0) = 0.000000; -NODES[18322](VELOCITY_X,0) = 0.000000; -NODES[18322](VELOCITY_Y,0) = 0.000000; -NODES[18322](VELOCITY_Z,0) = 0.000000; -NODES[18323](VELOCITY_X,0) = 0.000000; -NODES[18323](VELOCITY_Y,0) = 0.000000; -NODES[18323](VELOCITY_Z,0) = 0.000000; -NODES[18325](VELOCITY_X,0) = 0.000000; -NODES[18325](VELOCITY_Y,0) = 0.000000; -NODES[18325](VELOCITY_Z,0) = 0.000000; -NODES[18331](VELOCITY_X,0) = 0.000000; -NODES[18331](VELOCITY_Y,0) = 0.000000; -NODES[18331](VELOCITY_Z,0) = 0.000000; -NODES[18337](VELOCITY_X,0) = 0.000000; -NODES[18337](VELOCITY_Y,0) = 0.000000; -NODES[18337](VELOCITY_Z,0) = 0.000000; -NODES[18338](VELOCITY_X,0) = 0.000000; -NODES[18338](VELOCITY_Y,0) = 0.000000; -NODES[18338](VELOCITY_Z,0) = 0.000000; -NODES[18339](VELOCITY_X,0) = 0.000000; -NODES[18339](VELOCITY_Y,0) = 0.000000; -NODES[18339](VELOCITY_Z,0) = 0.000000; -NODES[18340](VELOCITY_X,0) = 0.000000; -NODES[18340](VELOCITY_Y,0) = 0.000000; -NODES[18340](VELOCITY_Z,0) = 0.000000; -NODES[18341](VELOCITY_X,0) = 0.000000; -NODES[18341](VELOCITY_Y,0) = 0.000000; -NODES[18341](VELOCITY_Z,0) = 0.000000; -NODES[18342](VELOCITY_X,0) = 0.000000; -NODES[18342](VELOCITY_Y,0) = 0.000000; -NODES[18342](VELOCITY_Z,0) = 0.000000; -NODES[18343](VELOCITY_X,0) = 0.000000; -NODES[18343](VELOCITY_Y,0) = 0.000000; -NODES[18343](VELOCITY_Z,0) = 0.000000; -NODES[18351](VELOCITY_X,0) = 0.000000; -NODES[18351](VELOCITY_Y,0) = 0.000000; -NODES[18351](VELOCITY_Z,0) = 0.000000; -NODES[18352](VELOCITY_X,0) = 0.000000; -NODES[18352](VELOCITY_Y,0) = 0.000000; -NODES[18352](VELOCITY_Z,0) = 0.000000; -NODES[18353](VELOCITY_X,0) = 0.000000; -NODES[18353](VELOCITY_Y,0) = 0.000000; -NODES[18353](VELOCITY_Z,0) = 0.000000; -NODES[18356](VELOCITY_X,0) = 0.000000; -NODES[18356](VELOCITY_Y,0) = 0.000000; -NODES[18356](VELOCITY_Z,0) = 0.000000; -NODES[18358](VELOCITY_X,0) = 0.000000; -NODES[18358](VELOCITY_Y,0) = 0.000000; -NODES[18358](VELOCITY_Z,0) = 0.000000; -NODES[18359](VELOCITY_X,0) = 0.000000; -NODES[18359](VELOCITY_Y,0) = 0.000000; -NODES[18359](VELOCITY_Z,0) = 0.000000; -NODES[18360](VELOCITY_X,0) = 0.000000; -NODES[18360](VELOCITY_Y,0) = 0.000000; -NODES[18360](VELOCITY_Z,0) = 0.000000; -NODES[18361](VELOCITY_X,0) = 0.000000; -NODES[18361](VELOCITY_Y,0) = 0.000000; -NODES[18361](VELOCITY_Z,0) = 0.000000; -NODES[18365](VELOCITY_X,0) = 0.000000; -NODES[18365](VELOCITY_Y,0) = 0.000000; -NODES[18365](VELOCITY_Z,0) = 0.000000; -NODES[18367](VELOCITY_X,0) = 0.000000; -NODES[18367](VELOCITY_Y,0) = 0.000000; -NODES[18367](VELOCITY_Z,0) = 0.000000; -NODES[18369](VELOCITY_X,0) = 0.000000; -NODES[18369](VELOCITY_Y,0) = 0.000000; -NODES[18369](VELOCITY_Z,0) = 0.000000; -NODES[18372](VELOCITY_X,0) = 0.000000; -NODES[18372](VELOCITY_Y,0) = 0.000000; -NODES[18372](VELOCITY_Z,0) = 0.000000; -NODES[18373](VELOCITY_X,0) = 0.000000; -NODES[18373](VELOCITY_Y,0) = 0.000000; -NODES[18373](VELOCITY_Z,0) = 0.000000; -NODES[18379](VELOCITY_X,0) = 0.000000; -NODES[18379](VELOCITY_Y,0) = 0.000000; -NODES[18379](VELOCITY_Z,0) = 0.000000; -NODES[18381](VELOCITY_X,0) = 0.000000; -NODES[18381](VELOCITY_Y,0) = 0.000000; -NODES[18381](VELOCITY_Z,0) = 0.000000; -NODES[18382](VELOCITY_X,0) = 0.000000; -NODES[18382](VELOCITY_Y,0) = 0.000000; -NODES[18382](VELOCITY_Z,0) = 0.000000; -NODES[18384](VELOCITY_X,0) = 0.000000; -NODES[18384](VELOCITY_Y,0) = 0.000000; -NODES[18384](VELOCITY_Z,0) = 0.000000; -NODES[18386](VELOCITY_X,0) = 0.000000; -NODES[18386](VELOCITY_Y,0) = 0.000000; -NODES[18386](VELOCITY_Z,0) = 0.000000; -NODES[18390](VELOCITY_X,0) = 0.000000; -NODES[18390](VELOCITY_Y,0) = 0.000000; -NODES[18390](VELOCITY_Z,0) = 0.000000; -NODES[18394](VELOCITY_X,0) = 0.000000; -NODES[18394](VELOCITY_Y,0) = 0.000000; -NODES[18394](VELOCITY_Z,0) = 0.000000; -NODES[18400](VELOCITY_X,0) = 0.000000; -NODES[18400](VELOCITY_Y,0) = 0.000000; -NODES[18400](VELOCITY_Z,0) = 0.000000; -NODES[18401](VELOCITY_X,0) = 0.000000; -NODES[18401](VELOCITY_Y,0) = 0.000000; -NODES[18401](VELOCITY_Z,0) = 0.000000; -NODES[18402](VELOCITY_X,0) = 0.000000; -NODES[18402](VELOCITY_Y,0) = 0.000000; -NODES[18402](VELOCITY_Z,0) = 0.000000; -NODES[18403](VELOCITY_X,0) = 0.000000; -NODES[18403](VELOCITY_Y,0) = 0.000000; -NODES[18403](VELOCITY_Z,0) = 0.000000; -NODES[18404](VELOCITY_X,0) = 0.000000; -NODES[18404](VELOCITY_Y,0) = 0.000000; -NODES[18404](VELOCITY_Z,0) = 0.000000; -NODES[18406](VELOCITY_X,0) = 0.000000; -NODES[18406](VELOCITY_Y,0) = 0.000000; -NODES[18406](VELOCITY_Z,0) = 0.000000; -NODES[18408](VELOCITY_X,0) = 0.000000; -NODES[18408](VELOCITY_Y,0) = 0.000000; -NODES[18408](VELOCITY_Z,0) = 0.000000; -NODES[18409](VELOCITY_X,0) = 0.000000; -NODES[18409](VELOCITY_Y,0) = 0.000000; -NODES[18409](VELOCITY_Z,0) = 0.000000; -NODES[18410](VELOCITY_X,0) = 0.000000; -NODES[18410](VELOCITY_Y,0) = 0.000000; -NODES[18410](VELOCITY_Z,0) = 0.000000; -NODES[18415](VELOCITY_X,0) = 0.000000; -NODES[18415](VELOCITY_Y,0) = 0.000000; -NODES[18415](VELOCITY_Z,0) = 0.000000; -NODES[18422](VELOCITY_X,0) = 0.000000; -NODES[18422](VELOCITY_Y,0) = 0.000000; -NODES[18422](VELOCITY_Z,0) = 0.000000; -NODES[18424](VELOCITY_X,0) = 0.000000; -NODES[18424](VELOCITY_Y,0) = 0.000000; -NODES[18424](VELOCITY_Z,0) = 0.000000; -NODES[18425](VELOCITY_X,0) = 0.000000; -NODES[18425](VELOCITY_Y,0) = 0.000000; -NODES[18425](VELOCITY_Z,0) = 0.000000; -NODES[18428](VELOCITY_X,0) = 0.000000; -NODES[18428](VELOCITY_Y,0) = 0.000000; -NODES[18428](VELOCITY_Z,0) = 0.000000; -NODES[18433](VELOCITY_X,0) = 0.000000; -NODES[18433](VELOCITY_Y,0) = 0.000000; -NODES[18433](VELOCITY_Z,0) = 0.000000; -NODES[18435](VELOCITY_X,0) = 0.000000; -NODES[18435](VELOCITY_Y,0) = 0.000000; -NODES[18435](VELOCITY_Z,0) = 0.000000; -NODES[18437](VELOCITY_X,0) = 0.000000; -NODES[18437](VELOCITY_Y,0) = 0.000000; -NODES[18437](VELOCITY_Z,0) = 0.000000; -NODES[18439](VELOCITY_X,0) = 0.000000; -NODES[18439](VELOCITY_Y,0) = 0.000000; -NODES[18439](VELOCITY_Z,0) = 0.000000; -NODES[18441](VELOCITY_X,0) = 0.000000; -NODES[18441](VELOCITY_Y,0) = 0.000000; -NODES[18441](VELOCITY_Z,0) = 0.000000; -NODES[18443](VELOCITY_X,0) = 0.000000; -NODES[18443](VELOCITY_Y,0) = 0.000000; -NODES[18443](VELOCITY_Z,0) = 0.000000; -NODES[18446](VELOCITY_X,0) = 0.000000; -NODES[18446](VELOCITY_Y,0) = 0.000000; -NODES[18446](VELOCITY_Z,0) = 0.000000; -NODES[18448](VELOCITY_X,0) = 0.000000; -NODES[18448](VELOCITY_Y,0) = 0.000000; -NODES[18448](VELOCITY_Z,0) = 0.000000; -NODES[18449](VELOCITY_X,0) = 0.000000; -NODES[18449](VELOCITY_Y,0) = 0.000000; -NODES[18449](VELOCITY_Z,0) = 0.000000; -NODES[18453](VELOCITY_X,0) = 0.000000; -NODES[18453](VELOCITY_Y,0) = 0.000000; -NODES[18453](VELOCITY_Z,0) = 0.000000; -NODES[18455](VELOCITY_X,0) = 0.000000; -NODES[18455](VELOCITY_Y,0) = 0.000000; -NODES[18455](VELOCITY_Z,0) = 0.000000; -NODES[18456](VELOCITY_X,0) = 0.000000; -NODES[18456](VELOCITY_Y,0) = 0.000000; -NODES[18456](VELOCITY_Z,0) = 0.000000; -NODES[18457](VELOCITY_X,0) = 0.000000; -NODES[18457](VELOCITY_Y,0) = 0.000000; -NODES[18457](VELOCITY_Z,0) = 0.000000; -NODES[18461](VELOCITY_X,0) = 0.000000; -NODES[18461](VELOCITY_Y,0) = 0.000000; -NODES[18461](VELOCITY_Z,0) = 0.000000; -NODES[18465](VELOCITY_X,0) = 0.000000; -NODES[18465](VELOCITY_Y,0) = 0.000000; -NODES[18465](VELOCITY_Z,0) = 0.000000; -NODES[18466](VELOCITY_X,0) = 0.000000; -NODES[18466](VELOCITY_Y,0) = 0.000000; -NODES[18466](VELOCITY_Z,0) = 0.000000; -NODES[18467](VELOCITY_X,0) = 0.000000; -NODES[18467](VELOCITY_Y,0) = 0.000000; -NODES[18467](VELOCITY_Z,0) = 0.000000; -NODES[18468](VELOCITY_X,0) = 0.000000; -NODES[18468](VELOCITY_Y,0) = 0.000000; -NODES[18468](VELOCITY_Z,0) = 0.000000; -NODES[18469](VELOCITY_X,0) = 0.000000; -NODES[18469](VELOCITY_Y,0) = 0.000000; -NODES[18469](VELOCITY_Z,0) = 0.000000; -NODES[18471](VELOCITY_X,0) = 0.000000; -NODES[18471](VELOCITY_Y,0) = 0.000000; -NODES[18471](VELOCITY_Z,0) = 0.000000; -NODES[18476](VELOCITY_X,0) = 0.000000; -NODES[18476](VELOCITY_Y,0) = 0.000000; -NODES[18476](VELOCITY_Z,0) = 0.000000; -NODES[18478](VELOCITY_X,0) = 0.000000; -NODES[18478](VELOCITY_Y,0) = 0.000000; -NODES[18478](VELOCITY_Z,0) = 0.000000; -NODES[18479](VELOCITY_X,0) = 0.000000; -NODES[18479](VELOCITY_Y,0) = 0.000000; -NODES[18479](VELOCITY_Z,0) = 0.000000; -NODES[18481](VELOCITY_X,0) = 0.000000; -NODES[18481](VELOCITY_Y,0) = 0.000000; -NODES[18481](VELOCITY_Z,0) = 0.000000; -NODES[18482](VELOCITY_X,0) = 0.000000; -NODES[18482](VELOCITY_Y,0) = 0.000000; -NODES[18482](VELOCITY_Z,0) = 0.000000; -NODES[18483](VELOCITY_X,0) = 0.000000; -NODES[18483](VELOCITY_Y,0) = 0.000000; -NODES[18483](VELOCITY_Z,0) = 0.000000; -NODES[18490](VELOCITY_X,0) = 0.000000; -NODES[18490](VELOCITY_Y,0) = 0.000000; -NODES[18490](VELOCITY_Z,0) = 0.000000; -NODES[18492](VELOCITY_X,0) = 0.000000; -NODES[18492](VELOCITY_Y,0) = 0.000000; -NODES[18492](VELOCITY_Z,0) = 0.000000; -NODES[18494](VELOCITY_X,0) = 0.000000; -NODES[18494](VELOCITY_Y,0) = 0.000000; -NODES[18494](VELOCITY_Z,0) = 0.000000; -NODES[18497](VELOCITY_X,0) = 0.000000; -NODES[18497](VELOCITY_Y,0) = 0.000000; -NODES[18497](VELOCITY_Z,0) = 0.000000; -NODES[18498](VELOCITY_X,0) = 0.000000; -NODES[18498](VELOCITY_Y,0) = 0.000000; -NODES[18498](VELOCITY_Z,0) = 0.000000; -NODES[18499](VELOCITY_X,0) = 0.000000; -NODES[18499](VELOCITY_Y,0) = 0.000000; -NODES[18499](VELOCITY_Z,0) = 0.000000; -NODES[18500](VELOCITY_X,0) = 0.000000; -NODES[18500](VELOCITY_Y,0) = 0.000000; -NODES[18500](VELOCITY_Z,0) = 0.000000; -NODES[18503](VELOCITY_X,0) = 0.000000; -NODES[18503](VELOCITY_Y,0) = 0.000000; -NODES[18503](VELOCITY_Z,0) = 0.000000; -NODES[18505](VELOCITY_X,0) = 0.000000; -NODES[18505](VELOCITY_Y,0) = 0.000000; -NODES[18505](VELOCITY_Z,0) = 0.000000; -NODES[18506](VELOCITY_X,0) = 0.000000; -NODES[18506](VELOCITY_Y,0) = 0.000000; -NODES[18506](VELOCITY_Z,0) = 0.000000; -NODES[18508](VELOCITY_X,0) = 0.000000; -NODES[18508](VELOCITY_Y,0) = 0.000000; -NODES[18508](VELOCITY_Z,0) = 0.000000; -NODES[18509](VELOCITY_X,0) = 0.000000; -NODES[18509](VELOCITY_Y,0) = 0.000000; -NODES[18509](VELOCITY_Z,0) = 0.000000; -NODES[18512](VELOCITY_X,0) = 0.000000; -NODES[18512](VELOCITY_Y,0) = 0.000000; -NODES[18512](VELOCITY_Z,0) = 0.000000; -NODES[18514](VELOCITY_X,0) = 0.000000; -NODES[18514](VELOCITY_Y,0) = 0.000000; -NODES[18514](VELOCITY_Z,0) = 0.000000; -NODES[18515](VELOCITY_X,0) = 0.000000; -NODES[18515](VELOCITY_Y,0) = 0.000000; -NODES[18515](VELOCITY_Z,0) = 0.000000; -NODES[18516](VELOCITY_X,0) = 0.000000; -NODES[18516](VELOCITY_Y,0) = 0.000000; -NODES[18516](VELOCITY_Z,0) = 0.000000; -NODES[18517](VELOCITY_X,0) = 0.000000; -NODES[18517](VELOCITY_Y,0) = 0.000000; -NODES[18517](VELOCITY_Z,0) = 0.000000; -NODES[18519](VELOCITY_X,0) = 0.000000; -NODES[18519](VELOCITY_Y,0) = 0.000000; -NODES[18519](VELOCITY_Z,0) = 0.000000; -NODES[18521](VELOCITY_X,0) = 0.000000; -NODES[18521](VELOCITY_Y,0) = 0.000000; -NODES[18521](VELOCITY_Z,0) = 0.000000; -NODES[18523](VELOCITY_X,0) = 0.000000; -NODES[18523](VELOCITY_Y,0) = 0.000000; -NODES[18523](VELOCITY_Z,0) = 0.000000; -NODES[18527](VELOCITY_X,0) = 0.000000; -NODES[18527](VELOCITY_Y,0) = 0.000000; -NODES[18527](VELOCITY_Z,0) = 0.000000; -NODES[18530](VELOCITY_X,0) = 0.000000; -NODES[18530](VELOCITY_Y,0) = 0.000000; -NODES[18530](VELOCITY_Z,0) = 0.000000; -NODES[18531](VELOCITY_X,0) = 0.000000; -NODES[18531](VELOCITY_Y,0) = 0.000000; -NODES[18531](VELOCITY_Z,0) = 0.000000; -NODES[18533](VELOCITY_X,0) = 0.000000; -NODES[18533](VELOCITY_Y,0) = 0.000000; -NODES[18533](VELOCITY_Z,0) = 0.000000; -NODES[18536](VELOCITY_X,0) = 0.000000; -NODES[18536](VELOCITY_Y,0) = 0.000000; -NODES[18536](VELOCITY_Z,0) = 0.000000; -NODES[18538](VELOCITY_X,0) = 0.000000; -NODES[18538](VELOCITY_Y,0) = 0.000000; -NODES[18538](VELOCITY_Z,0) = 0.000000; -NODES[18539](VELOCITY_X,0) = 0.000000; -NODES[18539](VELOCITY_Y,0) = 0.000000; -NODES[18539](VELOCITY_Z,0) = 0.000000; -NODES[18540](VELOCITY_X,0) = 0.000000; -NODES[18540](VELOCITY_Y,0) = 0.000000; -NODES[18540](VELOCITY_Z,0) = 0.000000; -NODES[18541](VELOCITY_X,0) = 0.000000; -NODES[18541](VELOCITY_Y,0) = 0.000000; -NODES[18541](VELOCITY_Z,0) = 0.000000; -NODES[18542](VELOCITY_X,0) = 0.000000; -NODES[18542](VELOCITY_Y,0) = 0.000000; -NODES[18542](VELOCITY_Z,0) = 0.000000; -NODES[18543](VELOCITY_X,0) = 0.000000; -NODES[18543](VELOCITY_Y,0) = 0.000000; -NODES[18543](VELOCITY_Z,0) = 0.000000; -NODES[18544](VELOCITY_X,0) = 0.000000; -NODES[18544](VELOCITY_Y,0) = 0.000000; -NODES[18544](VELOCITY_Z,0) = 0.000000; -NODES[18545](VELOCITY_X,0) = 0.000000; -NODES[18545](VELOCITY_Y,0) = 0.000000; -NODES[18545](VELOCITY_Z,0) = 0.000000; -NODES[18546](VELOCITY_X,0) = 0.000000; -NODES[18546](VELOCITY_Y,0) = 0.000000; -NODES[18546](VELOCITY_Z,0) = 0.000000; -NODES[18554](VELOCITY_X,0) = 0.000000; -NODES[18554](VELOCITY_Y,0) = 0.000000; -NODES[18554](VELOCITY_Z,0) = 0.000000; -NODES[18556](VELOCITY_X,0) = 0.000000; -NODES[18556](VELOCITY_Y,0) = 0.000000; -NODES[18556](VELOCITY_Z,0) = 0.000000; -NODES[18557](VELOCITY_X,0) = 0.000000; -NODES[18557](VELOCITY_Y,0) = 0.000000; -NODES[18557](VELOCITY_Z,0) = 0.000000; -NODES[18558](VELOCITY_X,0) = 0.000000; -NODES[18558](VELOCITY_Y,0) = 0.000000; -NODES[18558](VELOCITY_Z,0) = 0.000000; -NODES[18559](VELOCITY_X,0) = 0.000000; -NODES[18559](VELOCITY_Y,0) = 0.000000; -NODES[18559](VELOCITY_Z,0) = 0.000000; -NODES[18560](VELOCITY_X,0) = 0.000000; -NODES[18560](VELOCITY_Y,0) = 0.000000; -NODES[18560](VELOCITY_Z,0) = 0.000000; -NODES[18562](VELOCITY_X,0) = 0.000000; -NODES[18562](VELOCITY_Y,0) = 0.000000; -NODES[18562](VELOCITY_Z,0) = 0.000000; -NODES[18563](VELOCITY_X,0) = 0.000000; -NODES[18563](VELOCITY_Y,0) = 0.000000; -NODES[18563](VELOCITY_Z,0) = 0.000000; -NODES[18564](VELOCITY_X,0) = 0.000000; -NODES[18564](VELOCITY_Y,0) = 0.000000; -NODES[18564](VELOCITY_Z,0) = 0.000000; -NODES[18568](VELOCITY_X,0) = 0.000000; -NODES[18568](VELOCITY_Y,0) = 0.000000; -NODES[18568](VELOCITY_Z,0) = 0.000000; -NODES[18569](VELOCITY_X,0) = 0.000000; -NODES[18569](VELOCITY_Y,0) = 0.000000; -NODES[18569](VELOCITY_Z,0) = 0.000000; -NODES[18570](VELOCITY_X,0) = 0.000000; -NODES[18570](VELOCITY_Y,0) = 0.000000; -NODES[18570](VELOCITY_Z,0) = 0.000000; -NODES[18573](VELOCITY_X,0) = 0.000000; -NODES[18573](VELOCITY_Y,0) = 0.000000; -NODES[18573](VELOCITY_Z,0) = 0.000000; -NODES[18575](VELOCITY_X,0) = 0.000000; -NODES[18575](VELOCITY_Y,0) = 0.000000; -NODES[18575](VELOCITY_Z,0) = 0.000000; -NODES[18576](VELOCITY_X,0) = 0.000000; -NODES[18576](VELOCITY_Y,0) = 0.000000; -NODES[18576](VELOCITY_Z,0) = 0.000000; -NODES[18577](VELOCITY_X,0) = 0.000000; -NODES[18577](VELOCITY_Y,0) = 0.000000; -NODES[18577](VELOCITY_Z,0) = 0.000000; -NODES[18579](VELOCITY_X,0) = 0.000000; -NODES[18579](VELOCITY_Y,0) = 0.000000; -NODES[18579](VELOCITY_Z,0) = 0.000000; -NODES[18580](VELOCITY_X,0) = 0.000000; -NODES[18580](VELOCITY_Y,0) = 0.000000; -NODES[18580](VELOCITY_Z,0) = 0.000000; -NODES[18581](VELOCITY_X,0) = 0.000000; -NODES[18581](VELOCITY_Y,0) = 0.000000; -NODES[18581](VELOCITY_Z,0) = 0.000000; -NODES[18582](VELOCITY_X,0) = 0.000000; -NODES[18582](VELOCITY_Y,0) = 0.000000; -NODES[18582](VELOCITY_Z,0) = 0.000000; -NODES[18585](VELOCITY_X,0) = 0.000000; -NODES[18585](VELOCITY_Y,0) = 0.000000; -NODES[18585](VELOCITY_Z,0) = 0.000000; -NODES[18589](VELOCITY_X,0) = 0.000000; -NODES[18589](VELOCITY_Y,0) = 0.000000; -NODES[18589](VELOCITY_Z,0) = 0.000000; -NODES[18590](VELOCITY_X,0) = 0.000000; -NODES[18590](VELOCITY_Y,0) = 0.000000; -NODES[18590](VELOCITY_Z,0) = 0.000000; -NODES[18591](VELOCITY_X,0) = 0.000000; -NODES[18591](VELOCITY_Y,0) = 0.000000; -NODES[18591](VELOCITY_Z,0) = 0.000000; -NODES[18592](VELOCITY_X,0) = 0.000000; -NODES[18592](VELOCITY_Y,0) = 0.000000; -NODES[18592](VELOCITY_Z,0) = 0.000000; -NODES[18593](VELOCITY_X,0) = 0.000000; -NODES[18593](VELOCITY_Y,0) = 0.000000; -NODES[18593](VELOCITY_Z,0) = 0.000000; -NODES[18594](VELOCITY_X,0) = 0.000000; -NODES[18594](VELOCITY_Y,0) = 0.000000; -NODES[18594](VELOCITY_Z,0) = 0.000000; -NODES[18595](VELOCITY_X,0) = 0.000000; -NODES[18595](VELOCITY_Y,0) = 0.000000; -NODES[18595](VELOCITY_Z,0) = 0.000000; -NODES[18597](VELOCITY_X,0) = 0.000000; -NODES[18597](VELOCITY_Y,0) = 0.000000; -NODES[18597](VELOCITY_Z,0) = 0.000000; -NODES[18601](VELOCITY_X,0) = 0.000000; -NODES[18601](VELOCITY_Y,0) = 0.000000; -NODES[18601](VELOCITY_Z,0) = 0.000000; -NODES[18604](VELOCITY_X,0) = 0.000000; -NODES[18604](VELOCITY_Y,0) = 0.000000; -NODES[18604](VELOCITY_Z,0) = 0.000000; -NODES[18605](VELOCITY_X,0) = 0.000000; -NODES[18605](VELOCITY_Y,0) = 0.000000; -NODES[18605](VELOCITY_Z,0) = 0.000000; -NODES[18609](VELOCITY_X,0) = 0.000000; -NODES[18609](VELOCITY_Y,0) = 0.000000; -NODES[18609](VELOCITY_Z,0) = 0.000000; -NODES[18610](VELOCITY_X,0) = 0.000000; -NODES[18610](VELOCITY_Y,0) = 0.000000; -NODES[18610](VELOCITY_Z,0) = 0.000000; -NODES[18611](VELOCITY_X,0) = 0.000000; -NODES[18611](VELOCITY_Y,0) = 0.000000; -NODES[18611](VELOCITY_Z,0) = 0.000000; -NODES[18612](VELOCITY_X,0) = 0.000000; -NODES[18612](VELOCITY_Y,0) = 0.000000; -NODES[18612](VELOCITY_Z,0) = 0.000000; -NODES[18613](VELOCITY_X,0) = 0.000000; -NODES[18613](VELOCITY_Y,0) = 0.000000; -NODES[18613](VELOCITY_Z,0) = 0.000000; -NODES[18616](VELOCITY_X,0) = 0.000000; -NODES[18616](VELOCITY_Y,0) = 0.000000; -NODES[18616](VELOCITY_Z,0) = 0.000000; -NODES[18618](VELOCITY_X,0) = 0.000000; -NODES[18618](VELOCITY_Y,0) = 0.000000; -NODES[18618](VELOCITY_Z,0) = 0.000000; -NODES[18619](VELOCITY_X,0) = 0.000000; -NODES[18619](VELOCITY_Y,0) = 0.000000; -NODES[18619](VELOCITY_Z,0) = 0.000000; -NODES[18621](VELOCITY_X,0) = 0.000000; -NODES[18621](VELOCITY_Y,0) = 0.000000; -NODES[18621](VELOCITY_Z,0) = 0.000000; -NODES[18622](VELOCITY_X,0) = 0.000000; -NODES[18622](VELOCITY_Y,0) = 0.000000; -NODES[18622](VELOCITY_Z,0) = 0.000000; -NODES[18623](VELOCITY_X,0) = 0.000000; -NODES[18623](VELOCITY_Y,0) = 0.000000; -NODES[18623](VELOCITY_Z,0) = 0.000000; -NODES[18624](VELOCITY_X,0) = 0.000000; -NODES[18624](VELOCITY_Y,0) = 0.000000; -NODES[18624](VELOCITY_Z,0) = 0.000000; -NODES[18626](VELOCITY_X,0) = 0.000000; -NODES[18626](VELOCITY_Y,0) = 0.000000; -NODES[18626](VELOCITY_Z,0) = 0.000000; -NODES[18629](VELOCITY_X,0) = 0.000000; -NODES[18629](VELOCITY_Y,0) = 0.000000; -NODES[18629](VELOCITY_Z,0) = 0.000000; -NODES[18630](VELOCITY_X,0) = 0.000000; -NODES[18630](VELOCITY_Y,0) = 0.000000; -NODES[18630](VELOCITY_Z,0) = 0.000000; -NODES[18632](VELOCITY_X,0) = 0.000000; -NODES[18632](VELOCITY_Y,0) = 0.000000; -NODES[18632](VELOCITY_Z,0) = 0.000000; -NODES[18633](VELOCITY_X,0) = 0.000000; -NODES[18633](VELOCITY_Y,0) = 0.000000; -NODES[18633](VELOCITY_Z,0) = 0.000000; -NODES[18634](VELOCITY_X,0) = 0.000000; -NODES[18634](VELOCITY_Y,0) = 0.000000; -NODES[18634](VELOCITY_Z,0) = 0.000000; -NODES[18635](VELOCITY_X,0) = 0.000000; -NODES[18635](VELOCITY_Y,0) = 0.000000; -NODES[18635](VELOCITY_Z,0) = 0.000000; -NODES[18636](VELOCITY_X,0) = 0.000000; -NODES[18636](VELOCITY_Y,0) = 0.000000; -NODES[18636](VELOCITY_Z,0) = 0.000000; -NODES[18639](VELOCITY_X,0) = 0.000000; -NODES[18639](VELOCITY_Y,0) = 0.000000; -NODES[18639](VELOCITY_Z,0) = 0.000000; -NODES[18641](VELOCITY_X,0) = 0.000000; -NODES[18641](VELOCITY_Y,0) = 0.000000; -NODES[18641](VELOCITY_Z,0) = 0.000000; -NODES[18642](VELOCITY_X,0) = 0.000000; -NODES[18642](VELOCITY_Y,0) = 0.000000; -NODES[18642](VELOCITY_Z,0) = 0.000000; -NODES[18644](VELOCITY_X,0) = 0.000000; -NODES[18644](VELOCITY_Y,0) = 0.000000; -NODES[18644](VELOCITY_Z,0) = 0.000000; -NODES[18645](VELOCITY_X,0) = 0.000000; -NODES[18645](VELOCITY_Y,0) = 0.000000; -NODES[18645](VELOCITY_Z,0) = 0.000000; -NODES[18646](VELOCITY_X,0) = 0.000000; -NODES[18646](VELOCITY_Y,0) = 0.000000; -NODES[18646](VELOCITY_Z,0) = 0.000000; -NODES[18647](VELOCITY_X,0) = 0.000000; -NODES[18647](VELOCITY_Y,0) = 0.000000; -NODES[18647](VELOCITY_Z,0) = 0.000000; -NODES[18654](VELOCITY_X,0) = 0.000000; -NODES[18654](VELOCITY_Y,0) = 0.000000; -NODES[18654](VELOCITY_Z,0) = 0.000000; -NODES[18657](VELOCITY_X,0) = 0.000000; -NODES[18657](VELOCITY_Y,0) = 0.000000; -NODES[18657](VELOCITY_Z,0) = 0.000000; -NODES[18658](VELOCITY_X,0) = 0.000000; -NODES[18658](VELOCITY_Y,0) = 0.000000; -NODES[18658](VELOCITY_Z,0) = 0.000000; -NODES[18659](VELOCITY_X,0) = 0.000000; -NODES[18659](VELOCITY_Y,0) = 0.000000; -NODES[18659](VELOCITY_Z,0) = 0.000000; -NODES[18660](VELOCITY_X,0) = 0.000000; -NODES[18660](VELOCITY_Y,0) = 0.000000; -NODES[18660](VELOCITY_Z,0) = 0.000000; -NODES[18661](VELOCITY_X,0) = 0.000000; -NODES[18661](VELOCITY_Y,0) = 0.000000; -NODES[18661](VELOCITY_Z,0) = 0.000000; -NODES[18662](VELOCITY_X,0) = 0.000000; -NODES[18662](VELOCITY_Y,0) = 0.000000; -NODES[18662](VELOCITY_Z,0) = 0.000000; -NODES[18663](VELOCITY_X,0) = 0.000000; -NODES[18663](VELOCITY_Y,0) = 0.000000; -NODES[18663](VELOCITY_Z,0) = 0.000000; -NODES[18664](VELOCITY_X,0) = 0.000000; -NODES[18664](VELOCITY_Y,0) = 0.000000; -NODES[18664](VELOCITY_Z,0) = 0.000000; -NODES[18666](VELOCITY_X,0) = 0.000000; -NODES[18666](VELOCITY_Y,0) = 0.000000; -NODES[18666](VELOCITY_Z,0) = 0.000000; -NODES[18667](VELOCITY_X,0) = 0.000000; -NODES[18667](VELOCITY_Y,0) = 0.000000; -NODES[18667](VELOCITY_Z,0) = 0.000000; -NODES[18668](VELOCITY_X,0) = 0.000000; -NODES[18668](VELOCITY_Y,0) = 0.000000; -NODES[18668](VELOCITY_Z,0) = 0.000000; -NODES[18669](VELOCITY_X,0) = 0.000000; -NODES[18669](VELOCITY_Y,0) = 0.000000; -NODES[18669](VELOCITY_Z,0) = 0.000000; -NODES[18672](VELOCITY_X,0) = 0.000000; -NODES[18672](VELOCITY_Y,0) = 0.000000; -NODES[18672](VELOCITY_Z,0) = 0.000000; -NODES[18673](VELOCITY_X,0) = 0.000000; -NODES[18673](VELOCITY_Y,0) = 0.000000; -NODES[18673](VELOCITY_Z,0) = 0.000000; -NODES[18674](VELOCITY_X,0) = 0.000000; -NODES[18674](VELOCITY_Y,0) = 0.000000; -NODES[18674](VELOCITY_Z,0) = 0.000000; -NODES[18676](VELOCITY_X,0) = 0.000000; -NODES[18676](VELOCITY_Y,0) = 0.000000; -NODES[18676](VELOCITY_Z,0) = 0.000000; -NODES[18677](VELOCITY_X,0) = 0.000000; -NODES[18677](VELOCITY_Y,0) = 0.000000; -NODES[18677](VELOCITY_Z,0) = 0.000000; -NODES[18680](VELOCITY_X,0) = 0.000000; -NODES[18680](VELOCITY_Y,0) = 0.000000; -NODES[18680](VELOCITY_Z,0) = 0.000000; -NODES[18681](VELOCITY_X,0) = 0.000000; -NODES[18681](VELOCITY_Y,0) = 0.000000; -NODES[18681](VELOCITY_Z,0) = 0.000000; -NODES[18682](VELOCITY_X,0) = 0.000000; -NODES[18682](VELOCITY_Y,0) = 0.000000; -NODES[18682](VELOCITY_Z,0) = 0.000000; -NODES[18683](VELOCITY_X,0) = 0.000000; -NODES[18683](VELOCITY_Y,0) = 0.000000; -NODES[18683](VELOCITY_Z,0) = 0.000000; -NODES[18684](VELOCITY_X,0) = 0.000000; -NODES[18684](VELOCITY_Y,0) = 0.000000; -NODES[18684](VELOCITY_Z,0) = 0.000000; -NODES[18686](VELOCITY_X,0) = 0.000000; -NODES[18686](VELOCITY_Y,0) = 0.000000; -NODES[18686](VELOCITY_Z,0) = 0.000000; -NODES[18687](VELOCITY_X,0) = 0.000000; -NODES[18687](VELOCITY_Y,0) = 0.000000; -NODES[18687](VELOCITY_Z,0) = 0.000000; -NODES[18688](VELOCITY_X,0) = 0.000000; -NODES[18688](VELOCITY_Y,0) = 0.000000; -NODES[18688](VELOCITY_Z,0) = 0.000000; -NODES[18689](VELOCITY_X,0) = 0.000000; -NODES[18689](VELOCITY_Y,0) = 0.000000; -NODES[18689](VELOCITY_Z,0) = 0.000000; -NODES[18690](VELOCITY_X,0) = 0.000000; -NODES[18690](VELOCITY_Y,0) = 0.000000; -NODES[18690](VELOCITY_Z,0) = 0.000000; -NODES[18692](VELOCITY_X,0) = 0.000000; -NODES[18692](VELOCITY_Y,0) = 0.000000; -NODES[18692](VELOCITY_Z,0) = 0.000000; -NODES[18693](VELOCITY_X,0) = 0.000000; -NODES[18693](VELOCITY_Y,0) = 0.000000; -NODES[18693](VELOCITY_Z,0) = 0.000000; -NODES[18694](VELOCITY_X,0) = 0.000000; -NODES[18694](VELOCITY_Y,0) = 0.000000; -NODES[18694](VELOCITY_Z,0) = 0.000000; -NODES[18695](VELOCITY_X,0) = 0.000000; -NODES[18695](VELOCITY_Y,0) = 0.000000; -NODES[18695](VELOCITY_Z,0) = 0.000000; -NODES[18696](VELOCITY_X,0) = 0.000000; -NODES[18696](VELOCITY_Y,0) = 0.000000; -NODES[18696](VELOCITY_Z,0) = 0.000000; -NODES[18697](VELOCITY_X,0) = 0.000000; -NODES[18697](VELOCITY_Y,0) = 0.000000; -NODES[18697](VELOCITY_Z,0) = 0.000000; -NODES[18698](VELOCITY_X,0) = 0.000000; -NODES[18698](VELOCITY_Y,0) = 0.000000; -NODES[18698](VELOCITY_Z,0) = 0.000000; -NODES[18699](VELOCITY_X,0) = 0.000000; -NODES[18699](VELOCITY_Y,0) = 0.000000; -NODES[18699](VELOCITY_Z,0) = 0.000000; diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.lin b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.lin deleted file mode 100644 index 2bdfb64f5bc3..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.lin and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.mat b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.mat deleted file mode 100644 index 10484af2551b..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.mat +++ /dev/null @@ -1,12 +0,0 @@ -BOOK:Fluid_Material -NUMBER: 1 MATERIAL: Air -QUESTION: ID#CB#(Fluid) -VALUE: Fluid -STATE: HIDDEN -QUESTION: Density -VALUE: 1.2 -QUESTION: Viscosity -VALUE: 0.000017 -QUESTION: gravity -VALUE: 0 -END MATERIAL diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.msh b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.msh deleted file mode 100644 index 899a9be45233..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.msh and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.node b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.node deleted file mode 100644 index 0ea6de2ed26e..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.node +++ /dev/null @@ -1,18702 +0,0 @@ -NODES = NodesList([ -[1, 0.00000, 0.00000, 0.50000], -[2, 0.00000, 0.02500, 0.50000], -[3, 0.00000, 0.00000, 0.47500], -[4, 0.02500, 0.00000, 0.50000], -[5, 0.00000, 0.02500, 0.47631], -[6, 0.03542, 0.00000, 0.47779], -[7, 0.02500, 0.00000, 0.45670], -[8, 0.00000, 0.05000, 0.50000], -[9, 0.05000, 0.00000, 0.50000], -[10, 0.00000, 0.00000, 0.45000], -[11, 0.00000, 0.05000, 0.47631], -[12, 0.00000, 0.03542, 0.45389], -[13, 0.05000, 0.00000, 0.45670], -[14, 0.06250, 0.00000, 0.47835], -[15, 0.03036, 0.00000, 0.43575], -[16, 0.00000, 0.02500, 0.43301], -[17, 0.00000, 0.07500, 0.50000], -[18, 0.07500, 0.00000, 0.50000], -[19, 0.00000, 0.00000, 0.42500], -[20, 0.00000, 0.06250, 0.45466], -[21, 0.00000, 0.07500, 0.47631], -[22, 0.00000, 0.05000, 0.43301], -[23, 0.07500, 0.00000, 0.45670], -[24, 0.02315, 0.00000, 0.41345], -[25, 0.06250, 0.00000, 0.43505], -[26, 0.08750, 0.00000, 0.47835], -[27, 0.00000, 0.03036, 0.41169], -[28, 0.00000, 0.08750, 0.45466], -[29, 0.05000, 0.00000, 0.41340], -[30, 0.10000, 0.00000, 0.50000], -[31, 0.00000, 0.10000, 0.50000], -[32, 0.00000, 0.00000, 0.40000], -[33, 0.00000, 0.07500, 0.43301], -[34, 0.00000, 0.06250, 0.41136], -[35, 0.08750, 0.00000, 0.43505], -[36, 0.10000, 0.00000, 0.45670], -[37, 0.03542, 0.00000, 0.39312], -[38, 0.00000, 0.02315, 0.38912], -[39, 0.07500, 0.00000, 0.41340], -[40, 0.11250, 0.00000, 0.47835], -[41, 0.00000, 0.11250, 0.47835], -[42, 0.00000, 0.10000, 0.43301], -[43, 0.00000, 0.05000, 0.38971], -[44, 0.00000, 0.08750, 0.41136], -[45, 0.06250, 0.00000, 0.39175], -[46, 0.12500, 0.00000, 0.50000], -[47, 0.00000, 0.12500, 0.50000], -[48, 0.00000, 0.00000, 0.37500], -[49, 0.11250, 0.00000, 0.43505], -[50, 0.10000, 0.00000, 0.41340], -[51, 0.12500, 0.00000, 0.45670], -[52, 0.02500, 0.00000, 0.37010], -[53, 0.00000, 0.12500, 0.45670], -[54, 0.00000, 0.07500, 0.38971], -[55, 0.00000, 0.03542, 0.36922], -[56, 0.05000, 0.00000, 0.37010], -[57, 0.13750, 0.00000, 0.47835], -[58, 0.00000, 0.13750, 0.47835], -[59, 0.08750, 0.00000, 0.39175], -[60, 0.00000, 0.11250, 0.41136], -[61, 0.00000, 0.06250, 0.36806], -[62, 0.00000, 0.10000, 0.38971], -[63, 0.07500, 0.00000, 0.37010], -[64, 0.00000, 0.15000, 0.50000], -[65, 0.15000, 0.00000, 0.50000], -[66, 0.00000, 0.00000, 0.35000], -[67, 0.12500, 0.00000, 0.41340], -[68, 0.13750, 0.00000, 0.43505], -[69, 0.00000, 0.13750, 0.43505], -[70, 0.00000, 0.02500, 0.34641], -[71, 0.15000, 0.00000, 0.45670], -[72, 0.03750, 0.00000, 0.34845], -[73, 0.00000, 0.15000, 0.45670], -[74, 0.11250, 0.00000, 0.39175], -[75, 0.00000, 0.08750, 0.36806], -[76, 0.00000, 0.05000, 0.34641], -[77, 0.00000, 0.13750, 0.41136], -[78, 0.06250, 0.00000, 0.34845], -[79, 0.16250, 0.00000, 0.47835], -[80, 0.00000, 0.16250, 0.47835], -[81, 0.10000, 0.00000, 0.37010], -[82, 0.00000, 0.12500, 0.38971], -[83, 0.00000, 0.07500, 0.34641], -[84, 0.15000, 0.00000, 0.41340], -[85, 0.00000, 0.11250, 0.36806], -[86, 0.08750, 0.00000, 0.34845], -[87, 0.02500, 0.00000, 0.32679], -[88, 0.17500, 0.00000, 0.50000], -[89, 0.00000, 0.17500, 0.50000], -[90, 0.00000, 0.00000, 0.32500], -[91, 0.00000, 0.16250, 0.43505], -[92, 0.16250, 0.00000, 0.43505], -[93, 0.13750, 0.00000, 0.39175], -[94, 0.00000, 0.03750, 0.32476], -[95, 0.05000, 0.00000, 0.32679], -[96, 0.00000, 0.17500, 0.45670], -[97, 0.17500, 0.00000, 0.45670], -[98, 0.12500, 0.00000, 0.37010], -[99, 0.00000, 0.10000, 0.34641], -[100, 0.00000, 0.06250, 0.32476], -[101, 0.00000, 0.15000, 0.38971], -[102, 0.07500, 0.00000, 0.32679], -[103, 0.18750, 0.00000, 0.47835], -[104, 0.00000, 0.18750, 0.47835], -[105, 0.11250, 0.00000, 0.34845], -[106, 0.00000, 0.13750, 0.36806], -[107, 0.00000, 0.17500, 0.41340], -[108, 0.17500, 0.00000, 0.41340], -[109, 0.16250, 0.00000, 0.39175], -[110, 0.00000, 0.08750, 0.32476], -[111, 0.00000, 0.12500, 0.34641], -[112, 0.00000, 0.18750, 0.43505], -[113, 0.18750, 0.00000, 0.43505], -[114, 0.15000, 0.00000, 0.37010], -[115, 0.00000, 0.02500, 0.30311], -[116, 0.03542, 0.00000, 0.30429], -[117, 0.10000, 0.00000, 0.32679], -[118, 0.20000, 0.00000, 0.50000], -[119, 0.00000, 0.20000, 0.50000], -[120, 0.00000, 0.00000, 0.30000], -[121, 0.00000, 0.05000, 0.30311], -[122, 0.06250, 0.00000, 0.30514], -[123, 0.00000, 0.20000, 0.45670], -[124, 0.20000, 0.00000, 0.45670], -[125, 0.13750, 0.00000, 0.34845], -[126, 0.00000, 0.11250, 0.32476], -[127, 0.00000, 0.16250, 0.36806], -[128, 0.00000, 0.07500, 0.30311], -[129, 0.08750, 0.00000, 0.30514], -[130, 0.00000, 0.21250, 0.47835], -[131, 0.21250, 0.00000, 0.47835], -[132, 0.12500, 0.00000, 0.32679], -[133, 0.00000, 0.15000, 0.34641], -[134, 0.00000, 0.18750, 0.39175], -[135, 0.18750, 0.00000, 0.39175], -[136, 0.02500, 0.00000, 0.28349], -[137, 0.00000, 0.20000, 0.41340], -[138, 0.20000, 0.00000, 0.41340], -[139, 0.17500, 0.00000, 0.37010], -[140, 0.00000, 0.10000, 0.30311], -[141, 0.05000, 0.00000, 0.28349], -[142, 0.00000, 0.21250, 0.43505], -[143, 0.21250, 0.00000, 0.43505], -[144, 0.16250, 0.00000, 0.34845], -[145, 0.00000, 0.03542, 0.28038], -[146, 0.00000, 0.13750, 0.32476], -[147, 0.11250, 0.00000, 0.30514], -[148, 0.22500, 0.00000, 0.50000], -[149, 0.00000, 0.22500, 0.50000], -[150, 0.00000, 0.00000, 0.27500], -[151, 0.00000, 0.06250, 0.28146], -[152, 0.07500, 0.00000, 0.28349], -[153, 0.00000, 0.22500, 0.45670], -[154, 0.22500, 0.00000, 0.45670], -[155, 0.15000, 0.00000, 0.32679], -[156, 0.00000, 0.18750, 0.36806], -[157, 0.00000, 0.17500, 0.34641], -[158, 0.00000, 0.12500, 0.30311], -[159, 0.00000, 0.08750, 0.28146], -[160, 0.10000, 0.00000, 0.28349], -[161, 0.00000, 0.23750, 0.47835], -[162, 0.00000, 0.21250, 0.39175], -[163, 0.23750, 0.00000, 0.47835], -[164, 0.20000, 0.00000, 0.37010], -[165, 0.21250, 0.00000, 0.39175], -[166, 0.13750, 0.00000, 0.30514], -[167, 0.00000, 0.16250, 0.32476], -[168, 0.03036, 0.00000, 0.26203], -[169, 0.00000, 0.02315, 0.26063], -[170, 0.00000, 0.22500, 0.41340], -[171, 0.18750, 0.00000, 0.34845], -[172, 0.22500, 0.00000, 0.41340], -[173, 0.00000, 0.05000, 0.25981], -[174, 0.00000, 0.11250, 0.28146], -[175, 0.06250, 0.00000, 0.26184], -[176, 0.00000, 0.23750, 0.43505], -[177, 0.23750, 0.00000, 0.43505], -[178, 0.17500, 0.00000, 0.32679], -[179, 0.00000, 0.15000, 0.30311], -[180, 0.12500, 0.00000, 0.28349], -[181, 0.25000, 0.00000, 0.50000], -[182, 0.00000, 0.25000, 0.50000], -[183, 0.00000, 0.00000, 0.25000], -[184, 0.00000, 0.21250, 0.36806], -[185, 0.00000, 0.07500, 0.25981], -[186, 0.00000, 0.20000, 0.34641], -[187, 0.08750, 0.00000, 0.26184], -[188, 0.00000, 0.25000, 0.45670], -[189, 0.25000, 0.00000, 0.45670], -[190, 0.16250, 0.00000, 0.30514], -[191, 0.00000, 0.18750, 0.32476], -[192, 0.00000, 0.13750, 0.28146], -[193, 0.22500, 0.00000, 0.37010], -[194, 0.00000, 0.10000, 0.25981], -[195, 0.21250, 0.00000, 0.34845], -[196, 0.23750, 0.00000, 0.39175], -[197, 0.02315, 0.00000, 0.23937], -[198, 0.11250, 0.00000, 0.26184], -[199, 0.00000, 0.26250, 0.47835], -[200, 0.26250, 0.00000, 0.47835], -[201, 0.15000, 0.00000, 0.28349], -[202, 0.00000, 0.17500, 0.30311], -[203, 0.00000, 0.03036, 0.23797], -[204, 0.25000, 0.00000, 0.41340], -[205, 0.05000, 0.00000, 0.24019], -[206, 0.00000, 0.25000, 0.41340], -[207, 0.20000, 0.00000, 0.32679], -[208, 0.00000, 0.06250, 0.23816], -[209, 0.26250, 0.00000, 0.43505], -[210, 0.07500, 0.00000, 0.24019], -[211, 0.00000, 0.26250, 0.43505], -[212, 0.18750, 0.00000, 0.30514], -[213, 0.00000, 0.12500, 0.25981], -[214, 0.00000, 0.23750, 0.36806], -[215, 0.00000, 0.16250, 0.28146], -[216, 0.00000, 0.22500, 0.34641], -[217, 0.00000, 0.25000, 0.38971], -[218, 0.13750, 0.00000, 0.26184], -[219, 0.27500, 0.00000, 0.50000], -[220, 0.00000, 0.27500, 0.50000], -[221, 0.00000, 0.00000, 0.22500], -[222, 0.00000, 0.21250, 0.32476], -[223, 0.00000, 0.08750, 0.23816], -[224, 0.10000, 0.00000, 0.24019], -[225, 0.00000, 0.27500, 0.45670], -[226, 0.27500, 0.00000, 0.45670], -[227, 0.17500, 0.00000, 0.28349], -[228, 0.00000, 0.20000, 0.30311], -[229, 0.25000, 0.00000, 0.37010], -[230, 0.23750, 0.00000, 0.34845], -[231, 0.03542, 0.00000, 0.21962], -[232, 0.00000, 0.15000, 0.25981], -[233, 0.26250, 0.00000, 0.39175], -[234, 0.22500, 0.00000, 0.32679], -[235, 0.00000, 0.02500, 0.21651], -[236, 0.00000, 0.11250, 0.23816], -[237, 0.00000, 0.05000, 0.21651], -[238, 0.00000, 0.18750, 0.28146], -[239, 0.27500, 0.00000, 0.41340], -[240, 0.00000, 0.27500, 0.41340], -[241, 0.12500, 0.00000, 0.24019], -[242, 0.06250, 0.00000, 0.21854], -[243, 0.00000, 0.28750, 0.47835], -[244, 0.28750, 0.00000, 0.47835], -[245, 0.21250, 0.00000, 0.30514], -[246, 0.16250, 0.00000, 0.26184], -[247, 0.00000, 0.07500, 0.21651], -[248, 0.00000, 0.25000, 0.34641], -[249, 0.00000, 0.26250, 0.36806], -[250, 0.28750, 0.00000, 0.43505], -[251, 0.00000, 0.28750, 0.43505], -[252, 0.08750, 0.00000, 0.21854], -[253, 0.20000, 0.00000, 0.28349], -[254, 0.00000, 0.23750, 0.32476], -[255, 0.00000, 0.13750, 0.23816], -[256, 0.00000, 0.27500, 0.38971], -[257, 0.00000, 0.17500, 0.25981], -[258, 0.00000, 0.22500, 0.30311], -[259, 0.15000, 0.00000, 0.24019], -[260, 0.30000, 0.00000, 0.50000], -[261, 0.00000, 0.30000, 0.50000], -[262, 0.00000, 0.00000, 0.20000], -[263, 0.00000, 0.10000, 0.21651], -[264, 0.26250, 0.00000, 0.34845], -[265, 0.30000, 0.00000, 0.45670], -[266, 0.11250, 0.00000, 0.21854], -[267, 0.00000, 0.30000, 0.45670], -[268, 0.18750, 0.00000, 0.26184], -[269, 0.02500, 0.00000, 0.19689], -[270, 0.27500, 0.00000, 0.37010], -[271, 0.25000, 0.00000, 0.32679], -[272, 0.00000, 0.21250, 0.28146], -[273, 0.00000, 0.03542, 0.19571], -[274, 0.28750, 0.00000, 0.39175], -[275, 0.23750, 0.00000, 0.30514], -[276, 0.05000, 0.00000, 0.19689], -[277, 0.00000, 0.16250, 0.23816], -[278, 0.00000, 0.12500, 0.21651], -[279, 0.00000, 0.06250, 0.19486], -[280, 0.30000, 0.00000, 0.41340], -[281, 0.00000, 0.30000, 0.41340], -[282, 0.22500, 0.00000, 0.28349], -[283, 0.07500, 0.00000, 0.19689], -[284, 0.00000, 0.20000, 0.25981], -[285, 0.31250, 0.00000, 0.47835], -[286, 0.13750, 0.00000, 0.21854], -[287, 0.00000, 0.31250, 0.47835], -[288, 0.17500, 0.00000, 0.24019], -[289, 0.00000, 0.27500, 0.34641], -[290, 0.00000, 0.26250, 0.32476], -[291, 0.00000, 0.28750, 0.36806], -[292, 0.00000, 0.08750, 0.19486], -[293, 0.00000, 0.25000, 0.30311], -[294, 0.21250, 0.00000, 0.26184], -[295, 0.31250, 0.00000, 0.43505], -[296, 0.10000, 0.00000, 0.19689], -[297, 0.00000, 0.31250, 0.43505], -[298, 0.00000, 0.30000, 0.38971], -[299, 0.00000, 0.15000, 0.21651], -[300, 0.00000, 0.18750, 0.23816], -[301, 0.00000, 0.23750, 0.28146], -[302, 0.27500, 0.00000, 0.32679], -[303, 0.28750, 0.00000, 0.34845], -[304, 0.32500, 0.00000, 0.50000], -[305, 0.00000, 0.32500, 0.50000], -[306, 0.00000, 0.00000, 0.17500], -[307, 0.16250, 0.00000, 0.21854], -[308, 0.00000, 0.11250, 0.19486], -[309, 0.30000, 0.00000, 0.37010], -[310, 0.26250, 0.00000, 0.30514], -[311, 0.03750, 0.00000, 0.17524], -[312, 0.00000, 0.02500, 0.17321], -[313, 0.32500, 0.00000, 0.45670], -[314, 0.00000, 0.32500, 0.45670], -[315, 0.12500, 0.00000, 0.19689], -[316, 0.20000, 0.00000, 0.24019], -[317, 0.00000, 0.22500, 0.25981], -[318, 0.00000, 0.05000, 0.17321], -[319, 0.31250, 0.00000, 0.39175], -[320, 0.25000, 0.00000, 0.28349], -[321, 0.06250, 0.00000, 0.17524], -[322, 0.00000, 0.17500, 0.21651], -[323, 0.00000, 0.13750, 0.19486], -[324, 0.00000, 0.07500, 0.17321], -[325, 0.23750, 0.00000, 0.26184], -[326, 0.32500, 0.00000, 0.41340], -[327, 0.00000, 0.32500, 0.41340], -[328, 0.08750, 0.00000, 0.17524], -[329, 0.00000, 0.28750, 0.32476], -[330, 0.00000, 0.30000, 0.34641], -[331, 0.00000, 0.21250, 0.23816], -[332, 0.33750, 0.00000, 0.47835], -[333, 0.00000, 0.33750, 0.47835], -[334, 0.18750, 0.00000, 0.21854], -[335, 0.15000, 0.00000, 0.19689], -[336, 0.00000, 0.27500, 0.30311], -[337, 0.00000, 0.31250, 0.36806], -[338, 0.00000, 0.26250, 0.28146], -[339, 0.00000, 0.10000, 0.17321], -[340, 0.22500, 0.00000, 0.24019], -[341, 0.33750, 0.00000, 0.43505], -[342, 0.00000, 0.33750, 0.43505], -[343, 0.11250, 0.00000, 0.17524], -[344, 0.00000, 0.16250, 0.19486], -[345, 0.30000, 0.00000, 0.32679], -[346, 0.00000, 0.25000, 0.25981], -[347, 0.00000, 0.20000, 0.21651], -[348, 0.28750, 0.00000, 0.30514], -[349, 0.31250, 0.00000, 0.34845], -[350, 0.02500, 0.00000, 0.15359], -[351, 0.00000, 0.12500, 0.17321], -[352, 0.27500, 0.00000, 0.28349], -[353, 0.32500, 0.00000, 0.37010], -[354, 0.35000, 0.00000, 0.50000], -[355, 0.00000, 0.00000, 0.15000], -[356, 0.00000, 0.35000, 0.50000], -[357, 0.17500, 0.00000, 0.19689], -[358, 0.05000, 0.00000, 0.15359], -[359, 0.00000, 0.03750, 0.15155], -[360, 0.35000, 0.00000, 0.45670], -[361, 0.00000, 0.35000, 0.45670], -[362, 0.21250, 0.00000, 0.21854], -[363, 0.13750, 0.00000, 0.17524], -[364, 0.00000, 0.23750, 0.23816], -[365, 0.00000, 0.06250, 0.15155], -[366, 0.26250, 0.00000, 0.26184], -[367, 0.33750, 0.00000, 0.39175], -[368, 0.00000, 0.33750, 0.39175], -[369, 0.07500, 0.00000, 0.15359], -[370, 0.00000, 0.18750, 0.19486], -[371, 0.00000, 0.31250, 0.32476], -[372, 0.00000, 0.30000, 0.30311], -[373, 0.00000, 0.08750, 0.15155], -[374, 0.00000, 0.32500, 0.34641], -[375, 0.00000, 0.15000, 0.17321], -[376, 0.25000, 0.00000, 0.24019], -[377, 0.35000, 0.00000, 0.41340], -[378, 0.00000, 0.35000, 0.41340], -[379, 0.10000, 0.00000, 0.15359], -[380, 0.00000, 0.28750, 0.28146], -[381, 0.00000, 0.22500, 0.21651], -[382, 0.20000, 0.00000, 0.19689], -[383, 0.16250, 0.00000, 0.17524], -[384, 0.36250, 0.00000, 0.47835], -[385, 0.00000, 0.36250, 0.47835], -[386, 0.00000, 0.27500, 0.25981], -[387, 0.00000, 0.11250, 0.15155], -[388, 0.23750, 0.00000, 0.21854], -[389, 0.31250, 0.00000, 0.30514], -[390, 0.32500, 0.00000, 0.32679], -[391, 0.36250, 0.00000, 0.43505], -[392, 0.00000, 0.36250, 0.43505], -[393, 0.12500, 0.00000, 0.15359], -[394, 0.30000, 0.00000, 0.28349], -[395, 0.33750, 0.00000, 0.34845], -[396, 0.00000, 0.17500, 0.17321], -[397, 0.00000, 0.26250, 0.23816], -[398, 0.03542, 0.00000, 0.13078], -[399, 0.00000, 0.02500, 0.12990], -[400, 0.00000, 0.21250, 0.19486], -[401, 0.28750, 0.00000, 0.26184], -[402, 0.35000, 0.00000, 0.37010], -[403, 0.00000, 0.35000, 0.37010], -[404, 0.06250, 0.00000, 0.13194], -[405, 0.00000, 0.05000, 0.12990], -[406, 0.00000, 0.13750, 0.15155], -[407, 0.37500, 0.00000, 0.50000], -[408, 0.00000, 0.00000, 0.12500], -[409, 0.00000, 0.37500, 0.50000], -[410, 0.18750, 0.00000, 0.17524], -[411, 0.22500, 0.00000, 0.19689], -[412, 0.37500, 0.00000, 0.45670], -[413, 0.00000, 0.37500, 0.45670], -[414, 0.15000, 0.00000, 0.15359], -[415, 0.00000, 0.07500, 0.12990], -[416, 0.00000, 0.25000, 0.21651], -[417, 0.27500, 0.00000, 0.24019], -[418, 0.36250, 0.00000, 0.39175], -[419, 0.00000, 0.36250, 0.39175], -[420, 0.08750, 0.00000, 0.13194], -[421, 0.00000, 0.32500, 0.30311], -[422, 0.00000, 0.33750, 0.32476], -[423, 0.00000, 0.31250, 0.28146], -[424, 0.00000, 0.35000, 0.34641], -[425, 0.00000, 0.20000, 0.17321], -[426, 0.00000, 0.10000, 0.12990], -[427, 0.00000, 0.30000, 0.25981], -[428, 0.00000, 0.16250, 0.15155], -[429, 0.26250, 0.00000, 0.21854], -[430, 0.37500, 0.00000, 0.41340], -[431, 0.00000, 0.37500, 0.41340], -[432, 0.11250, 0.00000, 0.13194], -[433, 0.00000, 0.23750, 0.19486], -[434, 0.38750, 0.00000, 0.47835], -[435, 0.00000, 0.38750, 0.47835], -[436, 0.21250, 0.00000, 0.17524], -[437, 0.17500, 0.00000, 0.15359], -[438, 0.00000, 0.28750, 0.23816], -[439, 0.33750, 0.00000, 0.30514], -[440, 0.02315, 0.00000, 0.11088], -[441, 0.32500, 0.00000, 0.28349], -[442, 0.35000, 0.00000, 0.32679], -[443, 0.00000, 0.12500, 0.12990], -[444, 0.31250, 0.00000, 0.26184], -[445, 0.25000, 0.00000, 0.19689], -[446, 0.36250, 0.00000, 0.34845], -[447, 0.38750, 0.00000, 0.43505], -[448, 0.00000, 0.38750, 0.43505], -[449, 0.13750, 0.00000, 0.13194], -[450, 0.05000, 0.00000, 0.11029], -[451, 0.00000, 0.03542, 0.10688], -[452, 0.00000, 0.27500, 0.21651], -[453, 0.00000, 0.18750, 0.15155], -[454, 0.00000, 0.06250, 0.10825], -[455, 0.00000, 0.22500, 0.17321], -[456, 0.30000, 0.00000, 0.24019], -[457, 0.37500, 0.00000, 0.37010], -[458, 0.00000, 0.37500, 0.37010], -[459, 0.07500, 0.00000, 0.11029], -[460, 0.00000, 0.15000, 0.12990], -[461, 0.40000, 0.00000, 0.50000], -[462, 0.00000, 0.40000, 0.50000], -[463, 0.00000, 0.00000, 0.10000], -[464, 0.20000, 0.00000, 0.15359], -[465, 0.00000, 0.08750, 0.10825], -[466, 0.00000, 0.35000, 0.30311], -[467, 0.00000, 0.33750, 0.28146], -[468, 0.38750, 0.00000, 0.39175], -[469, 0.28750, 0.00000, 0.21854], -[470, 0.23750, 0.00000, 0.17524], -[471, 0.40000, 0.00000, 0.45670], -[472, 0.00000, 0.40000, 0.45670], -[473, 0.00000, 0.38750, 0.39175], -[474, 0.16250, 0.00000, 0.13194], -[475, 0.10000, 0.00000, 0.11029], -[476, 0.00000, 0.26250, 0.19486], -[477, 0.00000, 0.36250, 0.32476], -[478, 0.00000, 0.32500, 0.25981], -[479, 0.00000, 0.37500, 0.34641], -[480, 0.00000, 0.11250, 0.10825], -[481, 0.00000, 0.31250, 0.23816], -[482, 0.00000, 0.21250, 0.15155], -[483, 0.27500, 0.00000, 0.19689], -[484, 0.40000, 0.00000, 0.41340], -[485, 0.00000, 0.40000, 0.41340], -[486, 0.12500, 0.00000, 0.11029], -[487, 0.00000, 0.17500, 0.12990], -[488, 0.00000, 0.25000, 0.17321], -[489, 0.35000, 0.00000, 0.28349], -[490, 0.36250, 0.00000, 0.30514], -[491, 0.00000, 0.30000, 0.21651], -[492, 0.03036, 0.00000, 0.08831], -[493, 0.33750, 0.00000, 0.26184], -[494, 0.37500, 0.00000, 0.32679], -[495, 0.41250, 0.00000, 0.47835], -[496, 0.00000, 0.41250, 0.47835], -[497, 0.22500, 0.00000, 0.15359], -[498, 0.18750, 0.00000, 0.13194], -[499, 0.00000, 0.02315, 0.08655], -[500, 0.00000, 0.13750, 0.10825], -[501, 0.32500, 0.00000, 0.24019], -[502, 0.38750, 0.00000, 0.34845], -[503, 0.06250, 0.00000, 0.08864], -[504, 0.00000, 0.05000, 0.08660], -[505, 0.26250, 0.00000, 0.17524], -[506, 0.41250, 0.00000, 0.43505], -[507, 0.00000, 0.41250, 0.43505], -[508, 0.15000, 0.00000, 0.11029], -[509, 0.00000, 0.28750, 0.19486], -[510, 0.00000, 0.07500, 0.08660], -[511, 0.40000, 0.00000, 0.37010], -[512, 0.31250, 0.00000, 0.21854], -[513, 0.08750, 0.00000, 0.08864], -[514, 0.00000, 0.20000, 0.12990], -[515, 0.00000, 0.23750, 0.15155], -[516, 0.00000, 0.36250, 0.28146], -[517, 0.00000, 0.37500, 0.30311], -[518, 0.00000, 0.16250, 0.10825], -[519, 0.00000, 0.35000, 0.25981], -[520, 0.42500, 0.00000, 0.50000], -[521, 0.00000, 0.00000, 0.07500], -[522, 0.00000, 0.42500, 0.50000], -[523, 0.21250, 0.00000, 0.13194], -[524, 0.00000, 0.38750, 0.32476], -[525, 0.00000, 0.10000, 0.08660], -[526, 0.41250, 0.00000, 0.39175], -[527, 0.30000, 0.00000, 0.19689], -[528, 0.00000, 0.41250, 0.39175], -[529, 0.11250, 0.00000, 0.08864], -[530, 0.00000, 0.27500, 0.17321], -[531, 0.00000, 0.33750, 0.23816], -[532, 0.25000, 0.00000, 0.15359], -[533, 0.42500, 0.00000, 0.45670], -[534, 0.00000, 0.42500, 0.45670], -[535, 0.17500, 0.00000, 0.11029], -[536, 0.00000, 0.40000, 0.34641], -[537, 0.00000, 0.32500, 0.21651], -[538, 0.00000, 0.12500, 0.08660], -[539, 0.37500, 0.00000, 0.28349], -[540, 0.00000, 0.41250, 0.36806], -[541, 0.00000, 0.22500, 0.12990], -[542, 0.28750, 0.00000, 0.17524], -[543, 0.36250, 0.00000, 0.26184], -[544, 0.38750, 0.00000, 0.30514], -[545, 0.42500, 0.00000, 0.41340], -[546, 0.00000, 0.42500, 0.41340], -[547, 0.13750, 0.00000, 0.08864], -[548, 0.02500, 0.00000, 0.06699], -[549, 0.00000, 0.18750, 0.10825], -[550, 0.35000, 0.00000, 0.24019], -[551, 0.40000, 0.00000, 0.32679], -[552, 0.05000, 0.00000, 0.06699], -[553, 0.00000, 0.26250, 0.15155], -[554, 0.00000, 0.31250, 0.19486], -[555, 0.00000, 0.03036, 0.06425], -[556, 0.43750, 0.00000, 0.47835], -[557, 0.00000, 0.43750, 0.47835], -[558, 0.23750, 0.00000, 0.13194], -[559, 0.20000, 0.00000, 0.11029], -[560, 0.41250, 0.00000, 0.34845], -[561, 0.33750, 0.00000, 0.21854], -[562, 0.07500, 0.00000, 0.06699], -[563, 0.00000, 0.06250, 0.06495], -[564, 0.00000, 0.15000, 0.08660], -[565, 0.27500, 0.00000, 0.15359], -[566, 0.43750, 0.00000, 0.43505], -[567, 0.00000, 0.43750, 0.43505], -[568, 0.16250, 0.00000, 0.08864], -[569, 0.00000, 0.30000, 0.17321], -[570, 0.00000, 0.08750, 0.06495], -[571, 0.42500, 0.00000, 0.37010], -[572, 0.32500, 0.00000, 0.19689], -[573, 0.10000, 0.00000, 0.06699], -[574, 0.00000, 0.38750, 0.28146], -[575, 0.00000, 0.37500, 0.25981], -[576, 0.00000, 0.21250, 0.10825], -[577, 0.00000, 0.40000, 0.30311], -[578, 0.00000, 0.25000, 0.12990], -[579, 0.00000, 0.36250, 0.23816], -[580, 0.00000, 0.41250, 0.32476], -[581, 0.00000, 0.17500, 0.08660], -[582, 0.00000, 0.11250, 0.06495], -[583, 0.45000, 0.00000, 0.50000], -[584, 0.00000, 0.00000, 0.05000], -[585, 0.00000, 0.45000, 0.50000], -[586, 0.22500, 0.00000, 0.11029], -[587, 0.00000, 0.35000, 0.21651], -[588, 0.43750, 0.00000, 0.39175], -[589, 0.31250, 0.00000, 0.17524], -[590, 0.00000, 0.43750, 0.39175], -[591, 0.12500, 0.00000, 0.06699], -[592, 0.00000, 0.28750, 0.15155], -[593, 0.00000, 0.42500, 0.34641], -[594, 0.26250, 0.00000, 0.13194], -[595, 0.45000, 0.00000, 0.45670], -[596, 0.00000, 0.45000, 0.45670], -[597, 0.18750, 0.00000, 0.08864], -[598, 0.38750, 0.00000, 0.26184], -[599, 0.40000, 0.00000, 0.28349], -[600, 0.00000, 0.33750, 0.19486], -[601, 0.03542, 0.00000, 0.04611], -[602, 0.37500, 0.00000, 0.24019], -[603, 0.41250, 0.00000, 0.30514], -[604, 0.00000, 0.13750, 0.06495], -[605, 0.00000, 0.43750, 0.36806], -[606, 0.00000, 0.02500, 0.04330], -[607, 0.00000, 0.23750, 0.10825], -[608, 0.30000, 0.00000, 0.15359], -[609, 0.45000, 0.00000, 0.41340], -[610, 0.00000, 0.45000, 0.41340], -[611, 0.15000, 0.00000, 0.06699], -[612, 0.36250, 0.00000, 0.21854], -[613, 0.42500, 0.00000, 0.32679], -[614, 0.06250, 0.00000, 0.04534], -[615, 0.00000, 0.20000, 0.08660], -[616, 0.00000, 0.05000, 0.04330], -[617, 0.00000, 0.32500, 0.17321], -[618, 0.00000, 0.27500, 0.12990], -[619, 0.00000, 0.07500, 0.04330], -[620, 0.43750, 0.00000, 0.34845], -[621, 0.35000, 0.00000, 0.19689], -[622, 0.46250, 0.00000, 0.47835], -[623, 0.00000, 0.46250, 0.47835], -[624, 0.25000, 0.00000, 0.11029], -[625, 0.21250, 0.00000, 0.08864], -[626, 0.08750, 0.00000, 0.04534], -[627, 0.00000, 0.16250, 0.06495], -[628, 0.00000, 0.40000, 0.25981], -[629, 0.00000, 0.41250, 0.28146], -[630, 0.28750, 0.00000, 0.13194], -[631, 0.46250, 0.00000, 0.43505], -[632, 0.00000, 0.46250, 0.43505], -[633, 0.17500, 0.00000, 0.06699], -[634, 0.00000, 0.10000, 0.04330], -[635, 0.00000, 0.38750, 0.23816], -[636, 0.00000, 0.31250, 0.15155], -[637, 0.45000, 0.00000, 0.37010], -[638, 0.33750, 0.00000, 0.17524], -[639, 0.11250, 0.00000, 0.04534], -[640, 0.00000, 0.42500, 0.30311], -[641, 0.00000, 0.37500, 0.21651], -[642, 0.00000, 0.22500, 0.08660], -[643, 0.00000, 0.43750, 0.32476], -[644, 0.00000, 0.26250, 0.10825], -[645, 0.00000, 0.12500, 0.04330], -[646, 0.00000, 0.18750, 0.06495], -[647, 0.00000, 0.36250, 0.19486], -[648, 0.32500, 0.00000, 0.15359], -[649, 0.47500, 0.00000, 0.50000], -[650, 0.00000, 0.00000, 0.02500], -[651, 0.00000, 0.47500, 0.50000], -[652, 0.46250, 0.00000, 0.39175], -[653, 0.00000, 0.46250, 0.39175], -[654, 0.23750, 0.00000, 0.08864], -[655, 0.13750, 0.00000, 0.04534], -[656, 0.00000, 0.45000, 0.34641], -[657, 0.41250, 0.00000, 0.26184], -[658, 0.00000, 0.30000, 0.12990], -[659, 0.40000, 0.00000, 0.24019], -[660, 0.27500, 0.00000, 0.11029], -[661, 0.47500, 0.00000, 0.45670], -[662, 0.42500, 0.00000, 0.28349], -[663, 0.00000, 0.47500, 0.45670], -[664, 0.20000, 0.00000, 0.06699], -[665, 0.02500, 0.00000, 0.02369], -[666, 0.00000, 0.35000, 0.17321], -[667, 0.38750, 0.00000, 0.21854], -[668, 0.43750, 0.00000, 0.30514], -[669, 0.05000, 0.00000, 0.02369], -[670, 0.00000, 0.03542, 0.02221], -[671, 0.00000, 0.15000, 0.04330], -[672, 0.00000, 0.46250, 0.36806], -[673, 0.37500, 0.00000, 0.19689], -[674, 0.45000, 0.00000, 0.32679], -[675, 0.07500, 0.00000, 0.02369], -[676, 0.00000, 0.06250, 0.02165], -[677, 0.31250, 0.00000, 0.13194], -[678, 0.47500, 0.00000, 0.41340], -[679, 0.00000, 0.47500, 0.41340], -[680, 0.16250, 0.00000, 0.04534], -[681, 0.00000, 0.25000, 0.08660], -[682, 0.00000, 0.21250, 0.06495], -[683, 0.00000, 0.33750, 0.15155], -[684, 0.00000, 0.28750, 0.10825], -[685, 0.00000, 0.08750, 0.02165], -[686, 0.36250, 0.00000, 0.17524], -[687, 0.46250, 0.00000, 0.34845], -[688, 0.10000, 0.00000, 0.02369], -[689, 0.48750, 0.00000, 0.47835], -[690, 0.00000, 0.48750, 0.47835], -[691, 0.26250, 0.00000, 0.08864], -[692, 0.22500, 0.00000, 0.06699], -[693, 0.00000, 0.42500, 0.25981], -[694, 0.00000, 0.41250, 0.23816], -[695, 0.00000, 0.43750, 0.28146], -[696, 0.00000, 0.17500, 0.04330], -[697, 0.00000, 0.40000, 0.21651], -[698, 0.00000, 0.45000, 0.30311], -[699, 0.00000, 0.11250, 0.02165], -[700, 0.30000, 0.00000, 0.11029], -[701, 0.48750, 0.00000, 0.43505], -[702, 0.00000, 0.48750, 0.43505], -[703, 0.18750, 0.00000, 0.04534], -[704, 0.35000, 0.00000, 0.15359], -[705, 0.47500, 0.00000, 0.37010], -[706, 0.12500, 0.00000, 0.02369], -[707, 0.00000, 0.32500, 0.12990], -[708, 0.00000, 0.38750, 0.19486], -[709, 0.00000, 0.46250, 0.32476], -[710, 0.00000, 0.23750, 0.06495], -[711, 0.00000, 0.27500, 0.08660], -[712, 0.00000, 0.37500, 0.17321], -[713, 0.00000, 0.13750, 0.02165], -[714, 0.42500, 0.00000, 0.24019], -[715, 0.43750, 0.00000, 0.26184], -[716, 0.00000, 0.20000, 0.04330], -[717, 0.00000, 0.47500, 0.34641], -[718, 0.33750, 0.00000, 0.13194], -[719, 0.41250, 0.00000, 0.21854], -[720, 0.48750, 0.00000, 0.39175], -[721, 0.00000, 0.48750, 0.39175], -[722, 0.45000, 0.00000, 0.28349], -[723, 0.15000, 0.00000, 0.02369], -[724, 0.50000, 0.00000, 0.50000], -[725, 0.00000, 0.00000, 0.00000], -[726, 0.00000, 0.50000, 0.50000], -[727, 0.25000, 0.00000, 0.06699], -[728, 0.02500, 0.00000, 0.00000], -[729, 0.00000, 0.02500, 0.00000], -[730, 0.00000, 0.31250, 0.10825], -[731, 0.02369, 0.02500, 0.00000], -[732, 0.40000, 0.00000, 0.19689], -[733, 0.28750, 0.00000, 0.08864], -[734, 0.50000, 0.00000, 0.45670], -[735, 0.00000, 0.50000, 0.45670], -[736, 0.46250, 0.00000, 0.30514], -[737, 0.21250, 0.00000, 0.04534], -[738, 0.05000, 0.00000, 0.00000], -[739, 0.00000, 0.05000, 0.00000], -[740, 0.00000, 0.36250, 0.15155], -[741, 0.02369, 0.05000, 0.00000], -[742, 0.04611, 0.03542, 0.00000], -[743, 0.00000, 0.48750, 0.36806], -[744, 0.06699, 0.02500, 0.00000], -[745, 0.00000, 0.16250, 0.02165], -[746, 0.38750, 0.00000, 0.17524], -[747, 0.07500, 0.00000, 0.00000], -[748, 0.00000, 0.07500, 0.00000], -[749, 0.47500, 0.00000, 0.32679], -[750, 0.04534, 0.06250, 0.00000], -[751, 0.02369, 0.07500, 0.00000], -[752, 0.06699, 0.05000, 0.00000], -[753, 0.32500, 0.00000, 0.11029], -[754, 0.50000, 0.00000, 0.41340], -[755, 0.00000, 0.50000, 0.41340], -[756, 0.17500, 0.00000, 0.02369], -[757, 0.00000, 0.26250, 0.06495], -[758, 0.08831, 0.03036, 0.00000], -[759, 0.00000, 0.22500, 0.04330], -[760, 0.00000, 0.35000, 0.12990], -[761, 0.04534, 0.08750, 0.00000], -[762, 0.00000, 0.43750, 0.23816], -[763, 0.10000, 0.00000, 0.00000], -[764, 0.00000, 0.10000, 0.00000], -[765, 0.06699, 0.07500, 0.00000], -[766, 0.00000, 0.45000, 0.25981], -[767, 0.02369, 0.10000, 0.00000], -[768, 0.37500, 0.00000, 0.15359], -[769, 0.48750, 0.00000, 0.34845], -[770, 0.00000, 0.30000, 0.08660], -[771, 0.00000, 0.42500, 0.21651], -[772, 0.00000, 0.46250, 0.28146], -[773, 0.08864, 0.06250, 0.00000], -[774, 0.11088, 0.02315, 0.00000], -[775, 0.51250, 0.00000, 0.47835], -[776, 0.00000, 0.51250, 0.47835], -[777, 0.27500, 0.00000, 0.06699], -[778, 0.23750, 0.00000, 0.04534], -[779, 0.00000, 0.41250, 0.19486], -[780, 0.00000, 0.18750, 0.02165], -[781, 0.00000, 0.47500, 0.30311], -[782, 0.06699, 0.10000, 0.00000], -[783, 0.11029, 0.05000, 0.00000], -[784, 0.04534, 0.11250, 0.00000], -[785, 0.08864, 0.08750, 0.00000], -[786, 0.12500, 0.00000, 0.00000], -[787, 0.00000, 0.12500, 0.00000], -[788, 0.02369, 0.12500, 0.00000], -[789, 0.00000, 0.40000, 0.17321], -[790, 0.36250, 0.00000, 0.13194], -[791, 0.31250, 0.00000, 0.08864], -[792, 0.51250, 0.00000, 0.43505], -[793, 0.00000, 0.51250, 0.43505], -[794, 0.50000, 0.00000, 0.37010], -[795, 0.20000, 0.00000, 0.02369], -[796, 0.00000, 0.33750, 0.10825], -[797, 0.11029, 0.07500, 0.00000], -[798, 0.13078, 0.03542, 0.00000], -[799, 0.00000, 0.48750, 0.32476], -[800, 0.45000, 0.00000, 0.24019], -[801, 0.06699, 0.12500, 0.00000], -[802, 0.08864, 0.11250, 0.00000], -[803, 0.43750, 0.00000, 0.21854], -[804, 0.46250, 0.00000, 0.26184], -[805, 0.04534, 0.13750, 0.00000], -[806, 0.00000, 0.25000, 0.04330], -[807, 0.13194, 0.06250, 0.00000], -[808, 0.00000, 0.38750, 0.15155], -[809, 0.00000, 0.28750, 0.06495], -[810, 0.11029, 0.10000, 0.00000], -[811, 0.42500, 0.00000, 0.19689], -[812, 0.15000, 0.00000, 0.00000], -[813, 0.00000, 0.15000, 0.00000], -[814, 0.47500, 0.00000, 0.28349], -[815, 0.02369, 0.15000, 0.00000], -[816, 0.00000, 0.50000, 0.34641], -[817, 0.00000, 0.21250, 0.02165], -[818, 0.15359, 0.02500, 0.00000], -[819, 0.35000, 0.00000, 0.11029], -[820, 0.51250, 0.00000, 0.39175], -[821, 0.13194, 0.08750, 0.00000], -[822, 0.41250, 0.00000, 0.17524], -[823, 0.52500, 0.00000, 0.50000], -[824, 0.00000, 0.52500, 0.50000], -[825, 0.48750, 0.00000, 0.30514], -[826, 0.26250, 0.00000, 0.04534], -[827, 0.15359, 0.05000, 0.00000], -[828, 0.00000, 0.32500, 0.08660], -[829, 0.08864, 0.13750, 0.00000], -[830, 0.06699, 0.15000, 0.00000], -[831, 0.30000, 0.00000, 0.06699], -[832, 0.52500, 0.00000, 0.45670], -[833, 0.00000, 0.52500, 0.45670], -[834, 0.22500, 0.00000, 0.02369], -[835, 0.00000, 0.37500, 0.12990], -[836, 0.11029, 0.12500, 0.00000], -[837, 0.04534, 0.16250, 0.00000], -[838, 0.15359, 0.07500, 0.00000], -[839, 0.40000, 0.00000, 0.15359], -[840, 0.50000, 0.00000, 0.32679], -[841, 0.00000, 0.51250, 0.36806], -[842, 0.13194, 0.11250, 0.00000], -[843, 0.17500, 0.00000, 0.00000], -[844, 0.00000, 0.17500, 0.00000], -[845, 0.02369, 0.17500, 0.00000], -[846, 0.17524, 0.03750, 0.00000], -[847, 0.00000, 0.46250, 0.23816], -[848, 0.00000, 0.45000, 0.21651], -[849, 0.33750, 0.00000, 0.08864], -[850, 0.00000, 0.52500, 0.41340], -[851, 0.52500, 0.00000, 0.41340], -[852, 0.00000, 0.47500, 0.25981], -[853, 0.15359, 0.10000, 0.00000], -[854, 0.00000, 0.27500, 0.04330], -[855, 0.08864, 0.16250, 0.00000], -[856, 0.00000, 0.43750, 0.19486], -[857, 0.17524, 0.06250, 0.00000], -[858, 0.11029, 0.15000, 0.00000], -[859, 0.00000, 0.36250, 0.10825], -[860, 0.06699, 0.17500, 0.00000], -[861, 0.00000, 0.23750, 0.02165], -[862, 0.00000, 0.48750, 0.28146], -[863, 0.38750, 0.00000, 0.13194], -[864, 0.51250, 0.00000, 0.34845], -[865, 0.13194, 0.13750, 0.00000], -[866, 0.00000, 0.31250, 0.06495], -[867, 0.04534, 0.18750, 0.00000], -[868, 0.00000, 0.42500, 0.17321], -[869, 0.00000, 0.52500, 0.38971], -[870, 0.17524, 0.08750, 0.00000], -[871, 0.00000, 0.50000, 0.30311], -[872, 0.15359, 0.12500, 0.00000], -[873, 0.53750, 0.00000, 0.47835], -[874, 0.00000, 0.53750, 0.47835], -[875, 0.28750, 0.00000, 0.04534], -[876, 0.25000, 0.00000, 0.02369], -[877, 0.19689, 0.02500, 0.00000], -[878, 0.20000, 0.00000, 0.00000], -[879, 0.00000, 0.20000, 0.00000], -[880, 0.02369, 0.20000, 0.00000], -[881, 0.19689, 0.05000, 0.00000], -[882, 0.00000, 0.41250, 0.15155], -[883, 0.37500, 0.00000, 0.11029], -[884, 0.52500, 0.00000, 0.37010], -[885, 0.11029, 0.17500, 0.00000], -[886, 0.08864, 0.18750, 0.00000], -[887, 0.46250, 0.00000, 0.21854], -[888, 0.32500, 0.00000, 0.06699], -[889, 0.47500, 0.00000, 0.24019], -[890, 0.00000, 0.53750, 0.43505], -[891, 0.53750, 0.00000, 0.43505], -[892, 0.00000, 0.51250, 0.32476], -[893, 0.17524, 0.11250, 0.00000], -[894, 0.00000, 0.35000, 0.08660], -[895, 0.13194, 0.16250, 0.00000], -[896, 0.45000, 0.00000, 0.19689], -[897, 0.48750, 0.00000, 0.26184], -[898, 0.19689, 0.07500, 0.00000], -[899, 0.06699, 0.20000, 0.00000], -[900, 0.15359, 0.15000, 0.00000], -[901, 0.43750, 0.00000, 0.17524], -[902, 0.50000, 0.00000, 0.28349], -[903, 0.00000, 0.40000, 0.12990], -[904, 0.04534, 0.21250, 0.00000], -[905, 0.00000, 0.26250, 0.02165], -[906, 0.00000, 0.30000, 0.04330], -[907, 0.19689, 0.10000, 0.00000], -[908, 0.00000, 0.52500, 0.34641], -[909, 0.21962, 0.03542, 0.00000], -[910, 0.17524, 0.13750, 0.00000], -[911, 0.36250, 0.00000, 0.08864], -[912, 0.42500, 0.00000, 0.15359], -[913, 0.22500, 0.00000, 0.00000], -[914, 0.00000, 0.22500, 0.00000], -[915, 0.53750, 0.00000, 0.39175], -[916, 0.51250, 0.00000, 0.30514], -[917, 0.02369, 0.22500, 0.00000], -[918, 0.21854, 0.06250, 0.00000], -[919, 0.11029, 0.20000, 0.00000], -[920, 0.55000, 0.00000, 0.50000], -[921, 0.00000, 0.55000, 0.50000], -[922, 0.27500, 0.00000, 0.02369], -[923, 0.13194, 0.18750, 0.00000], -[924, 0.08864, 0.21250, 0.00000], -[925, 0.00000, 0.33750, 0.06495], -[926, 0.00000, 0.38750, 0.10825], -[927, 0.15359, 0.17500, 0.00000], -[928, 0.00000, 0.55000, 0.45670], -[929, 0.31250, 0.00000, 0.04534], -[930, 0.55000, 0.00000, 0.45670], -[931, 0.19689, 0.12500, 0.00000], -[932, 0.06699, 0.22500, 0.00000], -[933, 0.21854, 0.08750, 0.00000], -[934, 0.41250, 0.00000, 0.13194], -[935, 0.52500, 0.00000, 0.32679], -[936, 0.00000, 0.47500, 0.21651], -[937, 0.00000, 0.48750, 0.23816], -[938, 0.00000, 0.53750, 0.36806], -[939, 0.00000, 0.46250, 0.19486], -[940, 0.17524, 0.16250, 0.00000], -[941, 0.00000, 0.50000, 0.25981], -[942, 0.23937, 0.02315, 0.00000], -[943, 0.04534, 0.23750, 0.00000], -[944, 0.00000, 0.45000, 0.17321], -[945, 0.35000, 0.00000, 0.06699], -[946, 0.00000, 0.55000, 0.41340], -[947, 0.55000, 0.00000, 0.41340], -[948, 0.24019, 0.05000, 0.00000], -[949, 0.00000, 0.51250, 0.28146], -[950, 0.21854, 0.11250, 0.00000], -[951, 0.19689, 0.15000, 0.00000], -[952, 0.00000, 0.28750, 0.02165], -[953, 0.00000, 0.37500, 0.08660], -[954, 0.40000, 0.00000, 0.11029], -[955, 0.53750, 0.00000, 0.34845], -[956, 0.25000, 0.00000, 0.00000], -[957, 0.00000, 0.25000, 0.00000], -[958, 0.13194, 0.21250, 0.00000], -[959, 0.11029, 0.22500, 0.00000], -[960, 0.00000, 0.43750, 0.15155], -[961, 0.02369, 0.25000, 0.00000], -[962, 0.24019, 0.07500, 0.00000], -[963, 0.15359, 0.20000, 0.00000], -[964, 0.00000, 0.32500, 0.04330], -[965, 0.08864, 0.23750, 0.00000], -[966, 0.00000, 0.52500, 0.30311], -[967, 0.17524, 0.18750, 0.00000], -[968, 0.21854, 0.13750, 0.00000], -[969, 0.48750, 0.00000, 0.21854], -[970, 0.56250, 0.00000, 0.47835], -[971, 0.00000, 0.56250, 0.47835], -[972, 0.30000, 0.00000, 0.02369], -[973, 0.06699, 0.25000, 0.00000], -[974, 0.47500, 0.00000, 0.19689], -[975, 0.50000, 0.00000, 0.24019], -[976, 0.00000, 0.42500, 0.12990], -[977, 0.24019, 0.10000, 0.00000], -[978, 0.38750, 0.00000, 0.08864], -[979, 0.46250, 0.00000, 0.17524], -[980, 0.55000, 0.00000, 0.37010], -[981, 0.51250, 0.00000, 0.26184], -[982, 0.19689, 0.17500, 0.00000], -[983, 0.26203, 0.03036, 0.00000], -[984, 0.00000, 0.53750, 0.32476], -[985, 0.33750, 0.00000, 0.04534], -[986, 0.00000, 0.56250, 0.43505], -[987, 0.56250, 0.00000, 0.43505], -[988, 0.00000, 0.36250, 0.06495], -[989, 0.04534, 0.26250, 0.00000], -[990, 0.26184, 0.06250, 0.00000], -[991, 0.45000, 0.00000, 0.15359], -[992, 0.52500, 0.00000, 0.28349], -[993, 0.24019, 0.12500, 0.00000], -[994, 0.00000, 0.41250, 0.10825], -[995, 0.13194, 0.23750, 0.00000], -[996, 0.21854, 0.16250, 0.00000], -[997, 0.15359, 0.22500, 0.00000], -[998, 0.11029, 0.25000, 0.00000], -[999, 0.27500, 0.00000, 0.00000], -[1000, 0.00000, 0.27500, 0.00000], -[1001, 0.17524, 0.21250, 0.00000], -[1002, 0.00000, 0.55000, 0.34641], -[1003, 0.02369, 0.27500, 0.00000], -[1004, 0.26184, 0.08750, 0.00000], -[1005, 0.00000, 0.31250, 0.02165], -[1006, 0.08864, 0.26250, 0.00000], -[1007, 0.43750, 0.00000, 0.13194], -[1008, 0.53750, 0.00000, 0.30514], -[1009, 0.37500, 0.00000, 0.06699], -[1010, 0.56250, 0.00000, 0.39175], -[1011, 0.00000, 0.56250, 0.39175], -[1012, 0.19689, 0.20000, 0.00000], -[1013, 0.06699, 0.27500, 0.00000], -[1014, 0.24019, 0.15000, 0.00000], -[1015, 0.00000, 0.50000, 0.21651], -[1016, 0.57500, 0.00000, 0.50000], -[1017, 0.00000, 0.57500, 0.50000], -[1018, 0.00000, 0.48750, 0.19486], -[1019, 0.00000, 0.40000, 0.08660], -[1020, 0.28349, 0.02500, 0.00000], -[1021, 0.00000, 0.35000, 0.04330], -[1022, 0.00000, 0.51250, 0.23816], -[1023, 0.26184, 0.11250, 0.00000], -[1024, 0.00000, 0.47500, 0.17321], -[1025, 0.42500, 0.00000, 0.11029], -[1026, 0.00000, 0.57500, 0.45670], -[1027, 0.55000, 0.00000, 0.32679], -[1028, 0.57500, 0.00000, 0.45670], -[1029, 0.32500, 0.00000, 0.02369], -[1030, 0.28349, 0.05000, 0.00000], -[1031, 0.21854, 0.18750, 0.00000], -[1032, 0.00000, 0.52500, 0.25981], -[1033, 0.00000, 0.56250, 0.36806], -[1034, 0.04534, 0.28750, 0.00000], -[1035, 0.00000, 0.46250, 0.15155], -[1036, 0.28349, 0.07500, 0.00000], -[1037, 0.15359, 0.25000, 0.00000], -[1038, 0.13194, 0.26250, 0.00000], -[1039, 0.00000, 0.53750, 0.28146], -[1040, 0.17524, 0.23750, 0.00000], -[1041, 0.26184, 0.13750, 0.00000], -[1042, 0.11029, 0.27500, 0.00000], -[1043, 0.36250, 0.00000, 0.04534], -[1044, 0.00000, 0.57500, 0.41340], -[1045, 0.57500, 0.00000, 0.41340], -[1046, 0.24019, 0.17500, 0.00000], -[1047, 0.41250, 0.00000, 0.08864], -[1048, 0.56250, 0.00000, 0.34845], -[1049, 0.19689, 0.22500, 0.00000], -[1050, 0.00000, 0.38750, 0.06495], -[1051, 0.00000, 0.45000, 0.12990], -[1052, 0.30000, 0.00000, 0.00000], -[1053, 0.00000, 0.30000, 0.00000], -[1054, 0.28349, 0.10000, 0.00000], -[1055, 0.08864, 0.28750, 0.00000], -[1056, 0.02369, 0.30000, 0.00000], -[1057, 0.00000, 0.55000, 0.30311], -[1058, 0.50000, 0.00000, 0.19689], -[1059, 0.51250, 0.00000, 0.21854], -[1060, 0.00000, 0.33750, 0.02165], -[1061, 0.21854, 0.21250, 0.00000], -[1062, 0.48750, 0.00000, 0.17524], -[1063, 0.52500, 0.00000, 0.24019], -[1064, 0.30429, 0.03542, 0.00000], -[1065, 0.06699, 0.30000, 0.00000], -[1066, 0.00000, 0.43750, 0.10825], -[1067, 0.26184, 0.16250, 0.00000], -[1068, 0.47500, 0.00000, 0.15359], -[1069, 0.00000, 0.58750, 0.47835], -[1070, 0.58750, 0.00000, 0.47835], -[1071, 0.53750, 0.00000, 0.26184], -[1072, 0.28349, 0.12500, 0.00000], -[1073, 0.30514, 0.06250, 0.00000], -[1074, 0.00000, 0.56250, 0.32476], -[1075, 0.40000, 0.00000, 0.06699], -[1076, 0.57500, 0.00000, 0.37010], -[1077, 0.24019, 0.20000, 0.00000], -[1078, 0.00000, 0.37500, 0.04330], -[1079, 0.15359, 0.27500, 0.00000], -[1080, 0.35000, 0.00000, 0.02369], -[1081, 0.46250, 0.00000, 0.13194], -[1082, 0.00000, 0.58750, 0.43505], -[1083, 0.58750, 0.00000, 0.43505], -[1084, 0.55000, 0.00000, 0.28349], -[1085, 0.17524, 0.26250, 0.00000], -[1086, 0.04534, 0.31250, 0.00000], -[1087, 0.13194, 0.28750, 0.00000], -[1088, 0.30514, 0.08750, 0.00000], -[1089, 0.19689, 0.25000, 0.00000], -[1090, 0.00000, 0.42500, 0.08660], -[1091, 0.11029, 0.30000, 0.00000], -[1092, 0.28349, 0.15000, 0.00000], -[1093, 0.26184, 0.18750, 0.00000], -[1094, 0.21854, 0.23750, 0.00000], -[1095, 0.00000, 0.57500, 0.34641], -[1096, 0.45000, 0.00000, 0.11029], -[1097, 0.56250, 0.00000, 0.30514], -[1098, 0.08864, 0.31250, 0.00000], -[1099, 0.32500, 0.00000, 0.00000], -[1100, 0.00000, 0.32500, 0.00000], -[1101, 0.00000, 0.51250, 0.19486], -[1102, 0.30514, 0.11250, 0.00000], -[1103, 0.00000, 0.52500, 0.21651], -[1104, 0.02369, 0.32500, 0.00000], -[1105, 0.00000, 0.50000, 0.17321], -[1106, 0.38750, 0.00000, 0.04534], -[1107, 0.00000, 0.58750, 0.39175], -[1108, 0.58750, 0.00000, 0.39175], -[1109, 0.32679, 0.02500, 0.00000], -[1110, 0.00000, 0.53750, 0.23816], -[1111, 0.24019, 0.22500, 0.00000], -[1112, 0.00000, 0.48750, 0.15155], -[1113, 0.32679, 0.05000, 0.00000], -[1114, 0.00000, 0.41250, 0.06495], -[1115, 0.60000, 0.00000, 0.50000], -[1116, 0.00000, 0.60000, 0.50000], -[1117, 0.06699, 0.32500, 0.00000], -[1118, 0.00000, 0.55000, 0.25981], -[1119, 0.00000, 0.36250, 0.02165], -[1120, 0.43750, 0.00000, 0.08864], -[1121, 0.57500, 0.00000, 0.32679], -[1122, 0.28349, 0.17500, 0.00000], -[1123, 0.00000, 0.60000, 0.45670], -[1124, 0.60000, 0.00000, 0.45670], -[1125, 0.30514, 0.13750, 0.00000], -[1126, 0.32679, 0.07500, 0.00000], -[1127, 0.00000, 0.58750, 0.36806], -[1128, 0.00000, 0.47500, 0.12990], -[1129, 0.17524, 0.28750, 0.00000], -[1130, 0.15359, 0.30000, 0.00000], -[1131, 0.26184, 0.21250, 0.00000], -[1132, 0.00000, 0.56250, 0.28146], -[1133, 0.19689, 0.27500, 0.00000], -[1134, 0.13194, 0.31250, 0.00000], -[1135, 0.04534, 0.33750, 0.00000], -[1136, 0.21854, 0.26250, 0.00000], -[1137, 0.32679, 0.10000, 0.00000], -[1138, 0.00000, 0.46250, 0.10825], -[1139, 0.37500, 0.00000, 0.02369], -[1140, 0.52500, 0.00000, 0.19689], -[1141, 0.00000, 0.60000, 0.41340], -[1142, 0.60000, 0.00000, 0.41340], -[1143, 0.11029, 0.32500, 0.00000], -[1144, 0.42500, 0.00000, 0.06699], -[1145, 0.51250, 0.00000, 0.17524], -[1146, 0.58750, 0.00000, 0.34845], -[1147, 0.53750, 0.00000, 0.21854], -[1148, 0.00000, 0.40000, 0.04330], -[1149, 0.00000, 0.57500, 0.30311], -[1150, 0.30514, 0.16250, 0.00000], -[1151, 0.50000, 0.00000, 0.15359], -[1152, 0.55000, 0.00000, 0.24019], -[1153, 0.24019, 0.25000, 0.00000], -[1154, 0.28349, 0.20000, 0.00000], -[1155, 0.08864, 0.33750, 0.00000], -[1156, 0.32679, 0.12500, 0.00000], -[1157, 0.35000, 0.00000, 0.00000], -[1158, 0.00000, 0.35000, 0.00000], -[1159, 0.34845, 0.03750, 0.00000], -[1160, 0.02369, 0.35000, 0.00000], -[1161, 0.48750, 0.00000, 0.13194], -[1162, 0.56250, 0.00000, 0.26184], -[1163, 0.00000, 0.45000, 0.08660], -[1164, 0.26184, 0.23750, 0.00000], -[1165, 0.34845, 0.06250, 0.00000], -[1166, 0.00000, 0.61250, 0.47835], -[1167, 0.61250, 0.00000, 0.47835], -[1168, 0.00000, 0.58750, 0.32476], -[1169, 0.41250, 0.00000, 0.04534], -[1170, 0.60000, 0.00000, 0.37010], -[1171, 0.06699, 0.35000, 0.00000], -[1172, 0.47500, 0.00000, 0.11029], -[1173, 0.57500, 0.00000, 0.28349], -[1174, 0.30514, 0.18750, 0.00000], -[1175, 0.17524, 0.31250, 0.00000], -[1176, 0.19689, 0.30000, 0.00000], -[1177, 0.00000, 0.38750, 0.02165], -[1178, 0.34845, 0.08750, 0.00000], -[1179, 0.15359, 0.32500, 0.00000], -[1180, 0.32679, 0.15000, 0.00000], -[1181, 0.00000, 0.61250, 0.43505], -[1182, 0.61250, 0.00000, 0.43505], -[1183, 0.21854, 0.28750, 0.00000], -[1184, 0.00000, 0.43750, 0.06495], -[1185, 0.28349, 0.22500, 0.00000], -[1186, 0.13194, 0.33750, 0.00000], -[1187, 0.00000, 0.53750, 0.19486], -[1188, 0.00000, 0.52500, 0.17321], -[1189, 0.00000, 0.55000, 0.21651], -[1190, 0.46250, 0.00000, 0.08864], -[1191, 0.58750, 0.00000, 0.30514], -[1192, 0.24019, 0.27500, 0.00000], -[1193, 0.04534, 0.36250, 0.00000], -[1194, 0.00000, 0.60000, 0.34641], -[1195, 0.00000, 0.51250, 0.15155], -[1196, 0.34845, 0.11250, 0.00000], -[1197, 0.11029, 0.35000, 0.00000], -[1198, 0.00000, 0.56250, 0.23816], -[1199, 0.40000, 0.00000, 0.02369], -[1200, 0.00000, 0.61250, 0.39175], -[1201, 0.61250, 0.00000, 0.39175], -[1202, 0.00000, 0.50000, 0.12990], -[1203, 0.32679, 0.17500, 0.00000], -[1204, 0.26184, 0.26250, 0.00000], -[1205, 0.37010, 0.02500, 0.00000], -[1206, 0.30514, 0.21250, 0.00000], -[1207, 0.00000, 0.57500, 0.25981], -[1208, 0.00000, 0.42500, 0.04330], -[1209, 0.08864, 0.36250, 0.00000], -[1210, 0.37010, 0.05000, 0.00000], -[1211, 0.45000, 0.00000, 0.06699], -[1212, 0.60000, 0.00000, 0.32679], -[1213, 0.34845, 0.13750, 0.00000], -[1214, 0.37500, 0.00000, 0.00000], -[1215, 0.62500, 0.00000, 0.50000], -[1216, 0.00000, 0.37500, 0.00000], -[1217, 0.00000, 0.62500, 0.50000], -[1218, 0.00000, 0.48750, 0.10825], -[1219, 0.02369, 0.37500, 0.00000], -[1220, 0.00000, 0.62500, 0.45670], -[1221, 0.62500, 0.00000, 0.45670], -[1222, 0.00000, 0.61250, 0.36806], -[1223, 0.37010, 0.07500, 0.00000], -[1224, 0.28349, 0.25000, 0.00000], -[1225, 0.00000, 0.58750, 0.28146], -[1226, 0.53750, 0.00000, 0.17524], -[1227, 0.55000, 0.00000, 0.19689], -[1228, 0.19689, 0.32500, 0.00000], -[1229, 0.17524, 0.33750, 0.00000], -[1230, 0.06699, 0.37500, 0.00000], -[1231, 0.21854, 0.31250, 0.00000], -[1232, 0.52500, 0.00000, 0.15359], -[1233, 0.56250, 0.00000, 0.21854], -[1234, 0.15359, 0.35000, 0.00000], -[1235, 0.00000, 0.47500, 0.08660], -[1236, 0.32679, 0.20000, 0.00000], -[1237, 0.37010, 0.10000, 0.00000], -[1238, 0.24019, 0.30000, 0.00000], -[1239, 0.34845, 0.16250, 0.00000], -[1240, 0.43750, 0.00000, 0.04534], -[1241, 0.51250, 0.00000, 0.13194], -[1242, 0.00000, 0.62500, 0.41340], -[1243, 0.62500, 0.00000, 0.41340], -[1244, 0.61250, 0.00000, 0.34845], -[1245, 0.57500, 0.00000, 0.24019], -[1246, 0.00000, 0.60000, 0.30311], -[1247, 0.13194, 0.36250, 0.00000], -[1248, 0.00000, 0.41250, 0.02165], -[1249, 0.30514, 0.23750, 0.00000], -[1250, 0.26184, 0.28750, 0.00000], -[1251, 0.50000, 0.00000, 0.11029], -[1252, 0.58750, 0.00000, 0.26184], -[1253, 0.04534, 0.38750, 0.00000], -[1254, 0.37010, 0.12500, 0.00000], -[1255, 0.11029, 0.37500, 0.00000], -[1256, 0.00000, 0.46250, 0.06495], -[1257, 0.39312, 0.03542, 0.00000], -[1258, 0.00000, 0.61250, 0.32476], -[1259, 0.28349, 0.27500, 0.00000], -[1260, 0.34845, 0.18750, 0.00000], -[1261, 0.48750, 0.00000, 0.08864], -[1262, 0.00000, 0.63750, 0.47835], -[1263, 0.63750, 0.00000, 0.47835], -[1264, 0.60000, 0.00000, 0.28349], -[1265, 0.39175, 0.06250, 0.00000], -[1266, 0.32679, 0.22500, 0.00000], -[1267, 0.42500, 0.00000, 0.02369], -[1268, 0.62500, 0.00000, 0.37010], -[1269, 0.08864, 0.38750, 0.00000], -[1270, 0.00000, 0.55000, 0.17321], -[1271, 0.37010, 0.15000, 0.00000], -[1272, 0.00000, 0.56250, 0.19486], -[1273, 0.40000, 0.00000, 0.00000], -[1274, 0.00000, 0.40000, 0.00000], -[1275, 0.00000, 0.53750, 0.15155], -[1276, 0.02369, 0.40000, 0.00000], -[1277, 0.00000, 0.63750, 0.43505], -[1278, 0.63750, 0.00000, 0.43505], -[1279, 0.00000, 0.57500, 0.21651], -[1280, 0.00000, 0.45000, 0.04330], -[1281, 0.39175, 0.08750, 0.00000], -[1282, 0.19689, 0.35000, 0.00000], -[1283, 0.21854, 0.33750, 0.00000], -[1284, 0.30514, 0.26250, 0.00000], -[1285, 0.17524, 0.36250, 0.00000], -[1286, 0.00000, 0.52500, 0.12990], -[1287, 0.47500, 0.00000, 0.06699], -[1288, 0.61250, 0.00000, 0.30514], -[1289, 0.24019, 0.32500, 0.00000], -[1290, 0.00000, 0.58750, 0.23816], -[1291, 0.15359, 0.37500, 0.00000], -[1292, 0.00000, 0.62500, 0.34641], -[1293, 0.06699, 0.40000, 0.00000], -[1294, 0.00000, 0.51250, 0.10825], -[1295, 0.39175, 0.11250, 0.00000], -[1296, 0.26184, 0.31250, 0.00000], -[1297, 0.34845, 0.21250, 0.00000], -[1298, 0.13194, 0.38750, 0.00000], -[1299, 0.37010, 0.17500, 0.00000], -[1300, 0.00000, 0.60000, 0.25981], -[1301, 0.00000, 0.63750, 0.39175], -[1302, 0.63750, 0.00000, 0.39175], -[1303, 0.32679, 0.25000, 0.00000], -[1304, 0.00000, 0.43750, 0.02165], -[1305, 0.28349, 0.30000, 0.00000], -[1306, 0.46250, 0.00000, 0.04534], -[1307, 0.62500, 0.00000, 0.32679], -[1308, 0.00000, 0.50000, 0.08660], -[1309, 0.41345, 0.02315, 0.00000], -[1310, 0.11029, 0.40000, 0.00000], -[1311, 0.04534, 0.41250, 0.00000], -[1312, 0.39175, 0.13750, 0.00000], -[1313, 0.55000, 0.00000, 0.15359], -[1314, 0.65000, 0.00000, 0.50000], -[1315, 0.00000, 0.65000, 0.50000], -[1316, 0.00000, 0.61250, 0.28146], -[1317, 0.41340, 0.05000, 0.00000], -[1318, 0.00000, 0.63750, 0.36806], -[1319, 0.53750, 0.00000, 0.13194], -[1320, 0.00000, 0.65000, 0.45670], -[1321, 0.65000, 0.00000, 0.45670], -[1322, 0.30514, 0.28750, 0.00000], -[1323, 0.41340, 0.07500, 0.00000], -[1324, 0.00000, 0.48750, 0.06495], -[1325, 0.37010, 0.20000, 0.00000], -[1326, 0.52500, 0.00000, 0.11029], -[1327, 0.34845, 0.23750, 0.00000], -[1328, 0.08864, 0.41250, 0.00000], -[1329, 0.21854, 0.36250, 0.00000], -[1330, 0.45000, 0.00000, 0.02369], -[1331, 0.63750, 0.00000, 0.34845], -[1332, 0.19689, 0.37500, 0.00000], -[1333, 0.00000, 0.62500, 0.30311], -[1334, 0.39175, 0.16250, 0.00000], -[1335, 0.00000, 0.65000, 0.41340], -[1336, 0.65000, 0.00000, 0.41340], -[1337, 0.24019, 0.35000, 0.00000], -[1338, 0.42500, 0.00000, 0.00000], -[1339, 0.00000, 0.42500, 0.00000], -[1340, 0.17524, 0.38750, 0.00000], -[1341, 0.41340, 0.10000, 0.00000], -[1342, 0.02369, 0.42500, 0.00000], -[1343, 0.51250, 0.00000, 0.08864], -[1344, 0.32679, 0.27500, 0.00000], -[1345, 0.26184, 0.33750, 0.00000], -[1346, 0.15359, 0.40000, 0.00000], -[1347, 0.00000, 0.47500, 0.04330], -[1348, 0.06699, 0.42500, 0.00000], -[1349, 0.28349, 0.32500, 0.00000], -[1350, 0.41340, 0.12500, 0.00000], -[1351, 0.00000, 0.63750, 0.32476], -[1352, 0.57500, 0.00000, 0.17321], -[1353, 0.00000, 0.57500, 0.17321], -[1354, 0.50000, 0.00000, 0.06699], -[1355, 0.62500, 0.00000, 0.28349], -[1356, 0.13194, 0.41250, 0.00000], -[1357, 0.37010, 0.22500, 0.00000], -[1358, 0.00000, 0.56250, 0.15155], -[1359, 0.58750, 0.00000, 0.19486], -[1360, 0.00000, 0.58750, 0.19486], -[1361, 0.39175, 0.18750, 0.00000], -[1362, 0.00000, 0.66250, 0.47835], -[1363, 0.66250, 0.00000, 0.47835], -[1364, 0.65000, 0.00000, 0.37010], -[1365, 0.00000, 0.55000, 0.12990], -[1366, 0.34845, 0.26250, 0.00000], -[1367, 0.60000, 0.00000, 0.21651], -[1368, 0.00000, 0.60000, 0.21651], -[1369, 0.30514, 0.31250, 0.00000], -[1370, 0.43575, 0.03036, 0.00000], -[1371, 0.00000, 0.53750, 0.10825], -[1372, 0.00000, 0.46250, 0.02165], -[1373, 0.11029, 0.42500, 0.00000], -[1374, 0.00000, 0.66250, 0.43505], -[1375, 0.66250, 0.00000, 0.43505], -[1376, 0.43505, 0.06250, 0.00000], -[1377, 0.41340, 0.15000, 0.00000], -[1378, 0.04534, 0.43750, 0.00000], -[1379, 0.61250, 0.00000, 0.23816], -[1380, 0.00000, 0.61250, 0.23816], -[1381, 0.48750, 0.00000, 0.04534], -[1382, 0.63750, 0.00000, 0.30514], -[1383, 0.00000, 0.65000, 0.34641], -[1384, 0.00000, 0.52500, 0.08660], -[1385, 0.32679, 0.30000, 0.00000], -[1386, 0.43505, 0.08750, 0.00000], -[1387, 0.21854, 0.38750, 0.00000], -[1388, 0.24019, 0.37500, 0.00000], -[1389, 0.62500, 0.00000, 0.25981], -[1390, 0.00000, 0.62500, 0.25981], -[1391, 0.39175, 0.21250, 0.00000], -[1392, 0.19689, 0.40000, 0.00000], -[1393, 0.08864, 0.43750, 0.00000], -[1394, 0.37010, 0.25000, 0.00000], -[1395, 0.26184, 0.36250, 0.00000], -[1396, 0.66250, 0.00000, 0.39175], -[1397, 0.17524, 0.41250, 0.00000], -[1398, 0.41340, 0.17500, 0.00000], -[1399, 0.00000, 0.51250, 0.06495], -[1400, 0.43505, 0.11250, 0.00000], -[1401, 0.47500, 0.00000, 0.02369], -[1402, 0.45000, 0.00000, 0.00000], -[1403, 0.00000, 0.45000, 0.00000], -[1404, 0.65000, 0.00000, 0.32679], -[1405, 0.28349, 0.35000, 0.00000], -[1406, 0.02369, 0.45000, 0.00000], -[1407, 0.34845, 0.28750, 0.00000], -[1408, 0.00000, 0.63750, 0.28146], -[1409, 0.15359, 0.42500, 0.00000], -[1410, 0.67500, 0.00000, 0.50000], -[1411, 0.00000, 0.67500, 0.50000], -[1412, 0.00000, 0.66250, 0.36806], -[1413, 0.06699, 0.45000, 0.00000], -[1414, 0.30514, 0.33750, 0.00000], -[1415, 0.00000, 0.67500, 0.45670], -[1416, 0.67500, 0.00000, 0.45670], -[1417, 0.53750, 0.00000, 0.08864], -[1418, 0.43505, 0.13750, 0.00000], -[1419, 0.00000, 0.50000, 0.04330], -[1420, 0.13194, 0.43750, 0.00000], -[1421, 0.45670, 0.02500, 0.00000], -[1422, 0.39175, 0.23750, 0.00000], -[1423, 0.41340, 0.20000, 0.00000], -[1424, 0.45670, 0.05000, 0.00000], -[1425, 0.00000, 0.65000, 0.30311], -[1426, 0.66250, 0.00000, 0.34845], -[1427, 0.32679, 0.32500, 0.00000], -[1428, 0.37010, 0.27500, 0.00000], -[1429, 0.52500, 0.00000, 0.06699], -[1430, 0.00000, 0.67500, 0.41340], -[1431, 0.67500, 0.00000, 0.41340], -[1432, 0.45670, 0.07500, 0.00000], -[1433, 0.11029, 0.45000, 0.00000], -[1434, 0.43505, 0.16250, 0.00000], -[1435, 0.04534, 0.46250, 0.00000], -[1436, 0.00000, 0.48750, 0.02165], -[1437, 0.58750, 0.00000, 0.15155], -[1438, 0.00000, 0.58750, 0.15155], -[1439, 0.60000, 0.00000, 0.17321], -[1440, 0.00000, 0.60000, 0.17321], -[1441, 0.57500, 0.00000, 0.12990], -[1442, 0.00000, 0.57500, 0.12990], -[1443, 0.24019, 0.40000, 0.00000], -[1444, 0.00000, 0.67500, 0.38971], -[1445, 0.21854, 0.41250, 0.00000], -[1446, 0.61250, 0.00000, 0.19486], -[1447, 0.00000, 0.61250, 0.19486], -[1448, 0.45670, 0.10000, 0.00000], -[1449, 0.26184, 0.38750, 0.00000], -[1450, 0.34845, 0.31250, 0.00000], -[1451, 0.51250, 0.00000, 0.04534], -[1452, 0.65000, 0.00000, 0.28349], -[1453, 0.19689, 0.42500, 0.00000], -[1454, 0.00000, 0.66250, 0.32476], -[1455, 0.56250, 0.00000, 0.10825], -[1456, 0.00000, 0.56250, 0.10825], -[1457, 0.28349, 0.37500, 0.00000], -[1458, 0.00000, 0.62500, 0.21651], -[1459, 0.62500, 0.00000, 0.21651], -[1460, 0.41340, 0.22500, 0.00000], -[1461, 0.08864, 0.46250, 0.00000], -[1462, 0.17524, 0.43750, 0.00000], -[1463, 0.39175, 0.26250, 0.00000], -[1464, 0.67500, 0.00000, 0.37010], -[1465, 0.00000, 0.68750, 0.47835], -[1466, 0.68750, 0.00000, 0.47835], -[1467, 0.00000, 0.55000, 0.08660], -[1468, 0.45670, 0.12500, 0.00000], -[1469, 0.43505, 0.18750, 0.00000], -[1470, 0.30514, 0.36250, 0.00000], -[1471, 0.63750, 0.00000, 0.23816], -[1472, 0.00000, 0.63750, 0.23816], -[1473, 0.47500, 0.00000, 0.00000], -[1474, 0.00000, 0.47500, 0.00000], -[1475, 0.15359, 0.45000, 0.00000], -[1476, 0.02369, 0.47500, 0.00000], -[1477, 0.50000, 0.00000, 0.02369], -[1478, 0.00000, 0.68750, 0.43505], -[1479, 0.68750, 0.00000, 0.43505], -[1480, 0.66250, 0.00000, 0.30514], -[1481, 0.37010, 0.30000, 0.00000], -[1482, 0.00000, 0.53750, 0.06495], -[1483, 0.00000, 0.67500, 0.34641], -[1484, 0.32679, 0.35000, 0.00000], -[1485, 0.47779, 0.03542, 0.00000], -[1486, 0.06699, 0.47500, 0.00000], -[1487, 0.65000, 0.00000, 0.25981], -[1488, 0.00000, 0.65000, 0.25981], -[1489, 0.45670, 0.15000, 0.00000], -[1490, 0.13194, 0.46250, 0.00000], -[1491, 0.47835, 0.06250, 0.00000], -[1492, 0.41340, 0.25000, 0.00000], -[1493, 0.00000, 0.52500, 0.04330], -[1494, 0.68750, 0.00000, 0.39175], -[1495, 0.43505, 0.21250, 0.00000], -[1496, 0.34845, 0.33750, 0.00000], -[1497, 0.67500, 0.00000, 0.32679], -[1498, 0.39175, 0.28750, 0.00000], -[1499, 0.47835, 0.08750, 0.00000], -[1500, 0.00000, 0.66250, 0.28146], -[1501, 0.11029, 0.47500, 0.00000], -[1502, 0.24019, 0.42500, 0.00000], -[1503, 0.26184, 0.41250, 0.00000], -[1504, 0.21854, 0.43750, 0.00000], -[1505, 0.45670, 0.17500, 0.00000], -[1506, 0.04534, 0.48750, 0.00000], -[1507, 0.55000, 0.00000, 0.06699], -[1508, 0.70000, 0.00000, 0.50000], -[1509, 0.00000, 0.70000, 0.50000], -[1510, 0.00000, 0.68750, 0.36806], -[1511, 0.28349, 0.40000, 0.00000], -[1512, 0.19689, 0.45000, 0.00000], -[1513, 0.00000, 0.51250, 0.02165], -[1514, 0.47835, 0.11250, 0.00000], -[1515, 0.00000, 0.70000, 0.45670], -[1516, 0.70000, 0.00000, 0.45670], -[1517, 0.37010, 0.32500, 0.00000], -[1518, 0.30514, 0.38750, 0.00000], -[1519, 0.00000, 0.67500, 0.30311], -[1520, 0.17524, 0.46250, 0.00000], -[1521, 0.08864, 0.48750, 0.00000], -[1522, 0.53750, 0.00000, 0.04534], -[1523, 0.68750, 0.00000, 0.34845], -[1524, 0.43505, 0.23750, 0.00000], -[1525, 0.41340, 0.27500, 0.00000], -[1526, 0.61250, 0.00000, 0.15155], -[1527, 0.00000, 0.61250, 0.15155], -[1528, 0.60000, 0.00000, 0.12990], -[1529, 0.00000, 0.60000, 0.12990], -[1530, 0.32679, 0.37500, 0.00000], -[1531, 0.62500, 0.00000, 0.17321], -[1532, 0.00000, 0.62500, 0.17321], -[1533, 0.00000, 0.70000, 0.41340], -[1534, 0.70000, 0.00000, 0.41340], -[1535, 0.47835, 0.13750, 0.00000], -[1536, 0.45670, 0.20000, 0.00000], -[1537, 0.58750, 0.00000, 0.10825], -[1538, 0.00000, 0.58750, 0.10825], -[1539, 0.15359, 0.47500, 0.00000], -[1540, 0.63750, 0.00000, 0.19486], -[1541, 0.00000, 0.63750, 0.19486], -[1542, 0.50000, 0.00000, 0.00000], -[1543, 0.50000, 0.50000, 0.50000], -[1544, 0.00000, 0.50000, 0.00000], -[1545, 0.02369, 0.50000, 0.00000], -[1546, 0.50000, 0.50000, 0.47500], -[1547, 0.50000, 0.02500, 0.00000], -[1548, 0.39175, 0.31250, 0.00000], -[1549, 0.57500, 0.00000, 0.08660], -[1550, 0.00000, 0.57500, 0.08660], -[1551, 0.00000, 0.70000, 0.38971], -[1552, 0.52500, 0.00000, 0.02369], -[1553, 0.50000, 0.50000, 0.45000], -[1554, 0.67500, 0.00000, 0.28349], -[1555, 0.50000, 0.05000, 0.00000], -[1556, 0.34845, 0.36250, 0.00000], -[1557, 0.65000, 0.00000, 0.21651], -[1558, 0.00000, 0.65000, 0.21651], -[1559, 0.00000, 0.68750, 0.32476], -[1560, 0.06699, 0.50000, 0.00000], -[1561, 0.13194, 0.48750, 0.00000], -[1562, 0.47835, 0.16250, 0.00000], -[1563, 0.50000, 0.50000, 0.42500], -[1564, 0.50000, 0.07500, 0.00000], -[1565, 0.00000, 0.56250, 0.06495], -[1566, 0.70000, 0.00000, 0.37010], -[1567, 0.66250, 0.00000, 0.23816], -[1568, 0.00000, 0.66250, 0.23816], -[1569, 0.00000, 0.71250, 0.47835], -[1570, 0.71250, 0.00000, 0.47835], -[1571, 0.43505, 0.26250, 0.00000], -[1572, 0.45670, 0.22500, 0.00000], -[1573, 0.37010, 0.35000, 0.00000], -[1574, 0.26184, 0.43750, 0.00000], -[1575, 0.50000, 0.50000, 0.40000], -[1576, 0.50000, 0.10000, 0.00000], -[1577, 0.24019, 0.45000, 0.00000], -[1578, 0.68750, 0.00000, 0.30514], -[1579, 0.41340, 0.30000, 0.00000], -[1580, 0.28349, 0.42500, 0.00000], -[1581, 0.00000, 0.55000, 0.04330], -[1582, 0.21854, 0.46250, 0.00000], -[1583, 0.00000, 0.71250, 0.43505], -[1584, 0.71250, 0.00000, 0.43505], -[1585, 0.11029, 0.50000, 0.00000], -[1586, 0.30514, 0.41250, 0.00000], -[1587, 0.67500, 0.00000, 0.25981], -[1588, 0.00000, 0.67500, 0.25981], -[1589, 0.00000, 0.70000, 0.34641], -[1590, 0.47835, 0.18750, 0.00000], -[1591, 0.19689, 0.47500, 0.00000], -[1592, 0.04534, 0.51250, 0.00000], -[1593, 0.50000, 0.50000, 0.37500], -[1594, 0.50000, 0.12500, 0.00000], -[1595, 0.32679, 0.40000, 0.00000], -[1596, 0.39175, 0.33750, 0.00000], -[1597, 0.00000, 0.53750, 0.02165], -[1598, 0.17524, 0.48750, 0.00000], -[1599, 0.71250, 0.00000, 0.39175], -[1600, 0.70000, 0.00000, 0.32679], -[1601, 0.00000, 0.68750, 0.28146], -[1602, 0.08864, 0.51250, 0.00000], -[1603, 0.45670, 0.25000, 0.00000], -[1604, 0.34845, 0.38750, 0.00000], -[1605, 0.43505, 0.28750, 0.00000], -[1606, 0.50000, 0.50000, 0.35000], -[1607, 0.50000, 0.15000, 0.00000], -[1608, 0.56250, 0.00000, 0.04534], -[1609, 0.15359, 0.50000, 0.00000], -[1610, 0.52221, 0.50000, 0.46458], -[1611, 0.52221, 0.03542, 0.00000], -[1612, 0.47835, 0.21250, 0.00000], -[1613, 0.50000, 0.52369, 0.47500], -[1614, 0.00000, 0.71250, 0.36806], -[1615, 0.52500, 0.00000, 0.00000], -[1616, 0.50000, 0.52500, 0.50000], -[1617, 0.72500, 0.00000, 0.50000], -[1618, 0.52500, 0.50000, 0.50000], -[1619, 0.00000, 0.52500, 0.00000], -[1620, 0.00000, 0.72500, 0.50000], -[1621, 0.52165, 0.50000, 0.43750], -[1622, 0.52165, 0.06250, 0.00000], -[1623, 0.02369, 0.52500, 0.00000], -[1624, 0.41340, 0.32500, 0.00000], -[1625, 0.50000, 0.52369, 0.45000], -[1626, 0.00000, 0.72500, 0.45670], -[1627, 0.72500, 0.00000, 0.45670], -[1628, 0.62500, 0.00000, 0.12990], -[1629, 0.00000, 0.62500, 0.12990], -[1630, 0.37010, 0.37500, 0.00000], -[1631, 0.63750, 0.00000, 0.15155], -[1632, 0.00000, 0.63750, 0.15155], -[1633, 0.61250, 0.00000, 0.10825], -[1634, 0.00000, 0.61250, 0.10825], -[1635, 0.00000, 0.70000, 0.30311], -[1636, 0.65000, 0.00000, 0.17321], -[1637, 0.00000, 0.65000, 0.17321], -[1638, 0.55000, 0.00000, 0.02369], -[1639, 0.52165, 0.50000, 0.41250], -[1640, 0.52165, 0.08750, 0.00000], -[1641, 0.50000, 0.52369, 0.42500], -[1642, 0.13194, 0.51250, 0.00000], -[1643, 0.06699, 0.52500, 0.00000], -[1644, 0.50000, 0.50000, 0.32500], -[1645, 0.71250, 0.00000, 0.34845], -[1646, 0.50000, 0.17500, 0.00000], -[1647, 0.60000, 0.00000, 0.08660], -[1648, 0.00000, 0.60000, 0.08660], -[1649, 0.66250, 0.00000, 0.19486], -[1650, 0.00000, 0.66250, 0.19486], -[1651, 0.26184, 0.46250, 0.00000], -[1652, 0.28349, 0.45000, 0.00000], -[1653, 0.72500, 0.00000, 0.41340], -[1654, 0.24019, 0.47500, 0.00000], -[1655, 0.45670, 0.27500, 0.00000], -[1656, 0.58750, 0.00000, 0.06495], -[1657, 0.00000, 0.58750, 0.06495], -[1658, 0.30514, 0.43750, 0.00000], -[1659, 0.52165, 0.50000, 0.38750], -[1660, 0.50000, 0.52165, 0.38750], -[1661, 0.52165, 0.11250, 0.00000], -[1662, 0.39175, 0.36250, 0.00000], -[1663, 0.47835, 0.23750, 0.00000], -[1664, 0.51618, 0.51630, 0.45215], -[1665, 0.21854, 0.48750, 0.00000], -[1666, 0.67500, 0.00000, 0.21651], -[1667, 0.00000, 0.67500, 0.21651], -[1668, 0.70000, 0.00000, 0.28349], -[1669, 0.43505, 0.31250, 0.00000], -[1670, 0.32679, 0.42500, 0.00000], -[1671, 0.51887, 0.51756, 0.47686], -[1672, 0.11029, 0.52500, 0.00000], -[1673, 0.00000, 0.72500, 0.38971], -[1674, 0.00000, 0.71250, 0.32476], -[1675, 0.19689, 0.50000, 0.00000], -[1676, 0.00000, 0.57500, 0.04330], -[1677, 0.50000, 0.50000, 0.30000], -[1678, 0.50000, 0.20000, 0.00000], -[1679, 0.04534, 0.53750, 0.00000], -[1680, 0.52165, 0.50000, 0.36250], -[1681, 0.50000, 0.52165, 0.36250], -[1682, 0.52165, 0.13750, 0.00000], -[1683, 0.68750, 0.00000, 0.23816], -[1684, 0.00000, 0.68750, 0.23816], -[1685, 0.34845, 0.41250, 0.00000], -[1686, 0.72500, 0.00000, 0.37010], -[1687, 0.17524, 0.51250, 0.00000], -[1688, 0.41340, 0.35000, 0.00000], -[1689, 0.00000, 0.73750, 0.47835], -[1690, 0.73750, 0.00000, 0.47835], -[1691, 0.00000, 0.56250, 0.02165], -[1692, 0.71250, 0.00000, 0.30514], -[1693, 0.54330, 0.50000, 0.47500], -[1694, 0.54330, 0.02500, 0.00000], -[1695, 0.08864, 0.53750, 0.00000], -[1696, 0.37010, 0.40000, 0.00000], -[1697, 0.51919, 0.51227, 0.37687], -[1698, 0.54330, 0.50000, 0.45000], -[1699, 0.54330, 0.05000, 0.00000], -[1700, 0.00000, 0.70000, 0.25981], -[1701, 0.47835, 0.26250, 0.00000], -[1702, 0.50962, 0.53660, 0.48406], -[1703, 0.00000, 0.73750, 0.43505], -[1704, 0.73750, 0.00000, 0.43505], -[1705, 0.52165, 0.50000, 0.33750], -[1706, 0.50000, 0.52165, 0.33750], -[1707, 0.52165, 0.16250, 0.00000], -[1708, 0.45670, 0.30000, 0.00000], -[1709, 0.15359, 0.52500, 0.00000], -[1710, 0.00000, 0.72500, 0.34641], -[1711, 0.50000, 0.54611, 0.46458], -[1712, 0.53119, 0.51285, 0.42753], -[1713, 0.50000, 0.50000, 0.27500], -[1714, 0.50000, 0.22500, 0.00000], -[1715, 0.54330, 0.50000, 0.42500], -[1716, 0.54330, 0.07500, 0.00000], -[1717, 0.50000, 0.54534, 0.43750], -[1718, 0.00000, 0.73750, 0.41136], -[1719, 0.55000, 0.00000, 0.00000], -[1720, 0.00000, 0.55000, 0.00000], -[1721, 0.50000, 0.55000, 0.50000], -[1722, 0.55000, 0.50000, 0.50000], -[1723, 0.51516, 0.53169, 0.43119], -[1724, 0.02369, 0.55000, 0.00000], -[1725, 0.43505, 0.33750, 0.00000], -[1726, 0.39175, 0.38750, 0.00000], -[1727, 0.52278, 0.52147, 0.40798], -[1728, 0.50000, 0.54534, 0.41250], -[1729, 0.54330, 0.50000, 0.40000], -[1730, 0.54330, 0.10000, 0.00000], -[1731, 0.00000, 0.71250, 0.28146], -[1732, 0.73750, 0.00000, 0.39175], -[1733, 0.72500, 0.00000, 0.32679], -[1734, 0.28349, 0.47500, 0.00000], -[1735, 0.26184, 0.48750, 0.00000], -[1736, 0.13194, 0.53750, 0.00000], -[1737, 0.06699, 0.55000, 0.00000], -[1738, 0.30514, 0.46250, 0.00000], -[1739, 0.52165, 0.50000, 0.31250], -[1740, 0.50000, 0.52165, 0.31250], -[1741, 0.52165, 0.18750, 0.00000], -[1742, 0.57500, 0.00000, 0.02369], -[1743, 0.24019, 0.50000, 0.00000], -[1744, 0.51572, 0.53900, 0.45295], -[1745, 0.32679, 0.45000, 0.00000], -[1746, 0.52221, 0.53542, 0.50000], -[1747, 0.65000, 0.00000, 0.12990], -[1748, 0.00000, 0.65000, 0.12990], -[1749, 0.63750, 0.00000, 0.10825], -[1750, 0.00000, 0.63750, 0.10825], -[1751, 0.50000, 0.54534, 0.38750], -[1752, 0.51722, 0.53092, 0.39665], -[1753, 0.66250, 0.00000, 0.15155], -[1754, 0.00000, 0.66250, 0.15155], -[1755, 0.21854, 0.51250, 0.00000], -[1756, 0.54330, 0.50000, 0.37500], -[1757, 0.54330, 0.12500, 0.00000], -[1758, 0.00000, 0.73750, 0.36806], -[1759, 0.52784, 0.53089, 0.46862], -[1760, 0.47835, 0.28750, 0.00000], -[1761, 0.62500, 0.00000, 0.08660], -[1762, 0.00000, 0.62500, 0.08660], -[1763, 0.41340, 0.37500, 0.00000], -[1764, 0.67500, 0.00000, 0.17321], -[1765, 0.00000, 0.67500, 0.17321], -[1766, 0.75000, 0.00000, 0.50000], -[1767, 0.50000, 0.50000, 0.25000], -[1768, 0.00000, 0.75000, 0.50000], -[1769, 0.50000, 0.25000, 0.00000], -[1770, 0.34845, 0.43750, 0.00000], -[1771, 0.45670, 0.32500, 0.00000], -[1772, 0.75000, 0.00000, 0.45670], -[1773, 0.71250, 0.00000, 0.26184], -[1774, 0.00000, 0.75000, 0.45670], -[1775, 0.19689, 0.52500, 0.00000], -[1776, 0.00000, 0.72500, 0.30311], -[1777, 0.61250, 0.00000, 0.06495], -[1778, 0.00000, 0.61250, 0.06495], -[1779, 0.11029, 0.55000, 0.00000], -[1780, 0.68750, 0.00000, 0.19486], -[1781, 0.00000, 0.68750, 0.19486], -[1782, 0.50000, 0.54534, 0.36250], -[1783, 0.52416, 0.51873, 0.34856], -[1784, 0.73750, 0.00000, 0.34845], -[1785, 0.50000, 0.52165, 0.28750], -[1786, 0.52165, 0.50000, 0.28750], -[1787, 0.52165, 0.21250, 0.00000], -[1788, 0.37010, 0.42500, 0.00000], -[1789, 0.54330, 0.50000, 0.35000], -[1790, 0.54330, 0.15000, 0.00000], -[1791, 0.53414, 0.52881, 0.44378], -[1792, 0.04534, 0.56250, 0.00000], -[1793, 0.60000, 0.00000, 0.04330], -[1794, 0.00000, 0.60000, 0.04330], -[1795, 0.56425, 0.50000, 0.46964], -[1796, 0.17524, 0.53750, 0.00000], -[1797, 0.75000, 0.00000, 0.41340], -[1798, 0.70000, 0.00000, 0.21651], -[1799, 0.00000, 0.70000, 0.21651], -[1800, 0.43505, 0.36250, 0.00000], -[1801, 0.54330, 0.52500, 0.50000], -[1802, 0.51043, 0.52873, 0.32388], -[1803, 0.54625, 0.52243, 0.48591], -[1804, 0.50000, 0.56699, 0.47500], -[1805, 0.56670, 0.03527, 0.00000], -[1806, 0.72500, 0.00000, 0.28349], -[1807, 0.54029, 0.51776, 0.38702], -[1808, 0.54526, 0.51718, 0.40991], -[1809, 0.56495, 0.50000, 0.43750], -[1810, 0.56495, 0.06250, 0.00000], -[1811, 0.55028, 0.51875, 0.46488], -[1812, 0.51397, 0.54212, 0.37708], -[1813, 0.39175, 0.41250, 0.00000], -[1814, 0.50000, 0.54534, 0.33750], -[1815, 0.00000, 0.58750, 0.02165], -[1816, 0.50000, 0.56699, 0.45000], -[1817, 0.08864, 0.56250, 0.00000], -[1818, 0.52250, 0.54814, 0.47113], -[1819, 0.00000, 0.73750, 0.32476], -[1820, 0.00000, 0.75000, 0.38971], -[1821, 0.50000, 0.50000, 0.22500], -[1822, 0.50000, 0.27500, 0.00000], -[1823, 0.54330, 0.50000, 0.32500], -[1824, 0.54330, 0.17500, 0.00000], -[1825, 0.15359, 0.55000, 0.00000], -[1826, 0.00000, 0.71250, 0.23816], -[1827, 0.47835, 0.31250, 0.00000], -[1828, 0.53078, 0.52811, 0.37403], -[1829, 0.56495, 0.50000, 0.41250], -[1830, 0.56495, 0.08750, 0.00000], -[1831, 0.51854, 0.54857, 0.41600], -[1832, 0.50000, 0.56699, 0.42500], -[1833, 0.52165, 0.50000, 0.26250], -[1834, 0.52165, 0.23750, 0.00000], -[1835, 0.75000, 0.00000, 0.37010], -[1836, 0.53036, 0.51631, 0.32146], -[1837, 0.28349, 0.50000, 0.00000], -[1838, 0.57500, 0.00000, 0.00000], -[1839, 0.50000, 0.57500, 0.50000], -[1840, 0.57500, 0.50000, 0.50000], -[1841, 0.00000, 0.57500, 0.00000], -[1842, 0.30514, 0.48750, 0.00000], -[1843, 0.41340, 0.40000, 0.00000], -[1844, 0.45670, 0.35000, 0.00000], -[1845, 0.02369, 0.57500, 0.00000], -[1846, 0.51810, 0.54004, 0.35459], -[1847, 0.26184, 0.51250, 0.00000], -[1848, 0.50000, 0.56699, 0.40000], -[1849, 0.56495, 0.50000, 0.38750], -[1850, 0.56495, 0.11250, 0.00000], -[1851, 0.00000, 0.76250, 0.47835], -[1852, 0.76250, 0.00000, 0.47835], -[1853, 0.73750, 0.00000, 0.30514], -[1854, 0.54600, 0.51439, 0.35992], -[1855, 0.32679, 0.47500, 0.00000], -[1856, 0.50000, 0.54534, 0.31250], -[1857, 0.24019, 0.52500, 0.00000], -[1858, 0.00000, 0.72500, 0.25981], -[1859, 0.13194, 0.56250, 0.00000], -[1860, 0.06699, 0.57500, 0.00000], -[1861, 0.52803, 0.54984, 0.43687], -[1862, 0.54330, 0.50000, 0.30000], -[1863, 0.54330, 0.20000, 0.00000], -[1864, 0.34845, 0.46250, 0.00000], -[1865, 0.00000, 0.76250, 0.43505], -[1866, 0.76250, 0.00000, 0.43505], -[1867, 0.00000, 0.75000, 0.34641], -[1868, 0.52471, 0.53224, 0.33400], -[1869, 0.54009, 0.53727, 0.42360], -[1870, 0.52705, 0.51568, 0.29335], -[1871, 0.21854, 0.53750, 0.00000], -[1872, 0.50000, 0.52369, 0.25000], -[1873, 0.55541, 0.52326, 0.43110], -[1874, 0.50000, 0.56699, 0.37500], -[1875, 0.52212, 0.55936, 0.45516], -[1876, 0.56495, 0.50000, 0.36250], -[1877, 0.56495, 0.13750, 0.00000], -[1878, 0.54131, 0.54298, 0.48007], -[1879, 0.52165, 0.56250, 0.50000], -[1880, 0.53677, 0.54674, 0.45788], -[1881, 0.54198, 0.51800, 0.33524], -[1882, 0.00000, 0.76250, 0.41136], -[1883, 0.43505, 0.38750, 0.00000], -[1884, 0.37010, 0.45000, 0.00000], -[1885, 0.50000, 0.50000, 0.20000], -[1886, 0.50000, 0.30000, 0.00000], -[1887, 0.51601, 0.55894, 0.39278], -[1888, 0.54039, 0.53692, 0.39923], -[1889, 0.52165, 0.50000, 0.23750], -[1890, 0.52165, 0.26250, 0.00000], -[1891, 0.19689, 0.55000, 0.00000], -[1892, 0.00000, 0.73750, 0.28146], -[1893, 0.51225, 0.52712, 0.27247], -[1894, 0.66250, 0.00000, 0.10825], -[1895, 0.00000, 0.66250, 0.10825], -[1896, 0.75000, 0.00000, 0.32679], -[1897, 0.50000, 0.54534, 0.28750], -[1898, 0.67500, 0.00000, 0.12990], -[1899, 0.00000, 0.67500, 0.12990], -[1900, 0.47835, 0.33750, 0.00000], -[1901, 0.11029, 0.57500, 0.00000], -[1902, 0.72500, 0.00000, 0.24019], -[1903, 0.76250, 0.00000, 0.39175], -[1904, 0.65000, 0.00000, 0.08660], -[1905, 0.00000, 0.65000, 0.08660], -[1906, 0.51420, 0.55244, 0.34432], -[1907, 0.50000, 0.56699, 0.35000], -[1908, 0.68750, 0.00000, 0.15155], -[1909, 0.00000, 0.68750, 0.15155], -[1910, 0.51889, 0.51462, 0.25499], -[1911, 0.58655, 0.50000, 0.47685], -[1912, 0.39175, 0.43750, 0.00000], -[1913, 0.52453, 0.56524, 0.47779], -[1914, 0.58704, 0.02414, 0.00000], -[1915, 0.55626, 0.53236, 0.45024], -[1916, 0.52785, 0.51442, 0.27172], -[1917, 0.56495, 0.50000, 0.33750], -[1918, 0.56495, 0.16250, 0.00000], -[1919, 0.51870, 0.53681, 0.30392], -[1920, 0.63750, 0.00000, 0.06495], -[1921, 0.00000, 0.63750, 0.06495], -[1922, 0.54330, 0.50000, 0.27500], -[1923, 0.54330, 0.22500, 0.00000], -[1924, 0.58660, 0.50000, 0.45000], -[1925, 0.58660, 0.05000, 0.00000], -[1926, 0.70000, 0.00000, 0.17321], -[1927, 0.00000, 0.70000, 0.17321], -[1928, 0.50000, 0.58831, 0.46964], -[1929, 0.17524, 0.56250, 0.00000], -[1930, 0.04534, 0.58750, 0.00000], -[1931, 0.54330, 0.55000, 0.50000], -[1932, 0.57054, 0.52143, 0.48119], -[1933, 0.51504, 0.56084, 0.36382], -[1934, 0.00000, 0.76250, 0.36806], -[1935, 0.62500, 0.00000, 0.04330], -[1936, 0.00000, 0.62500, 0.04330], -[1937, 0.45670, 0.37500, 0.00000], -[1938, 0.56425, 0.53036, 0.50000], -[1939, 0.58660, 0.50000, 0.42500], -[1940, 0.58660, 0.07500, 0.00000], -[1941, 0.50000, 0.52369, 0.22500], -[1942, 0.50000, 0.58864, 0.43750], -[1943, 0.77500, 0.00000, 0.50000], -[1944, 0.00000, 0.77500, 0.50000], -[1945, 0.73750, 0.00000, 0.26184], -[1946, 0.71250, 0.00000, 0.19486], -[1947, 0.00000, 0.71250, 0.19486], -[1948, 0.54134, 0.53458, 0.35137], -[1949, 0.51663, 0.54982, 0.32163], -[1950, 0.00000, 0.75000, 0.30311], -[1951, 0.41340, 0.42500, 0.00000], -[1952, 0.50000, 0.56699, 0.32500], -[1953, 0.77500, 0.00000, 0.45670], -[1954, 0.00000, 0.77500, 0.45670], -[1955, 0.53395, 0.54788, 0.36871], -[1956, 0.54572, 0.54890, 0.43889], -[1957, 0.08864, 0.58750, 0.00000], -[1958, 0.52612, 0.56305, 0.40385], -[1959, 0.56588, 0.51617, 0.37127], -[1960, 0.51620, 0.57522, 0.42190], -[1961, 0.50000, 0.54534, 0.26250], -[1962, 0.61250, 0.00000, 0.02165], -[1963, 0.00000, 0.61250, 0.02165], -[1964, 0.58660, 0.50000, 0.40000], -[1965, 0.58660, 0.10000, 0.00000], -[1966, 0.56056, 0.52774, 0.39321], -[1967, 0.50000, 0.58864, 0.41250], -[1968, 0.15359, 0.57500, 0.00000], -[1969, 0.56495, 0.50000, 0.31250], -[1970, 0.56495, 0.18750, 0.00000], -[1971, 0.76250, 0.00000, 0.34845], -[1972, 0.55086, 0.53354, 0.37163], -[1973, 0.52165, 0.50000, 0.21250], -[1974, 0.52165, 0.28750, 0.00000], -[1975, 0.51650, 0.58062, 0.46401], -[1976, 0.57266, 0.51928, 0.41134], -[1977, 0.55758, 0.53603, 0.41440], -[1978, 0.50000, 0.50000, 0.17500], -[1979, 0.50000, 0.32500, 0.00000], -[1980, 0.30514, 0.51250, 0.00000], -[1981, 0.28349, 0.52500, 0.00000], -[1982, 0.72500, 0.00000, 0.21651], -[1983, 0.00000, 0.72500, 0.21651], -[1984, 0.32679, 0.50000, 0.00000], -[1985, 0.55120, 0.51897, 0.31563], -[1986, 0.26184, 0.53750, 0.00000], -[1987, 0.54330, 0.50000, 0.25000], -[1988, 0.54330, 0.25000, 0.00000], -[1989, 0.52541, 0.53400, 0.28401], -[1990, 0.77500, 0.00000, 0.41340], -[1991, 0.34845, 0.48750, 0.00000], -[1992, 0.50000, 0.58864, 0.38750], -[1993, 0.75000, 0.00000, 0.28349], -[1994, 0.43505, 0.41250, 0.00000], -[1995, 0.58660, 0.50000, 0.37500], -[1996, 0.58660, 0.12500, 0.00000], -[1997, 0.54468, 0.55362, 0.41744], -[1998, 0.60000, 0.00000, 0.00000], -[1999, 0.60000, 0.50000, 0.50000], -[2000, 0.00000, 0.60000, 0.00000], -[2001, 0.50000, 0.60000, 0.50000], -[2002, 0.56182, 0.54175, 0.46869], -[2003, 0.24019, 0.55000, 0.00000], -[2004, 0.47835, 0.36250, 0.00000], -[2005, 0.02369, 0.60000, 0.00000], -[2006, 0.52340, 0.51255, 0.22768], -[2007, 0.53328, 0.56760, 0.43096], -[2008, 0.50000, 0.56699, 0.30000], -[2009, 0.58342, 0.51876, 0.45377], -[2010, 0.55089, 0.55357, 0.45494], -[2011, 0.00000, 0.76250, 0.32476], -[2012, 0.56356, 0.51723, 0.33549], -[2013, 0.52008, 0.52602, 0.24465], -[2014, 0.00000, 0.73750, 0.23816], -[2015, 0.13194, 0.58750, 0.00000], -[2016, 0.37010, 0.47500, 0.00000], -[2017, 0.00000, 0.77500, 0.38971], -[2018, 0.53787, 0.55851, 0.39183], -[2019, 0.53653, 0.53992, 0.31587], -[2020, 0.21854, 0.56250, 0.00000], -[2021, 0.50000, 0.52369, 0.20000], -[2022, 0.56495, 0.50000, 0.28750], -[2023, 0.56495, 0.21250, 0.00000], -[2024, 0.06699, 0.60000, 0.00000], -[2025, 0.50000, 0.58864, 0.36250], -[2026, 0.54958, 0.53483, 0.33407], -[2027, 0.50000, 0.54534, 0.23750], -[2028, 0.58660, 0.50000, 0.35000], -[2029, 0.58660, 0.15000, 0.00000], -[2030, 0.52165, 0.58750, 0.50000], -[2031, 0.39175, 0.46250, 0.00000], -[2032, 0.58728, 0.52205, 0.50000], -[2033, 0.51241, 0.55089, 0.27324], -[2034, 0.56232, 0.52866, 0.35233], -[2035, 0.77500, 0.00000, 0.37010], -[2036, 0.45670, 0.40000, 0.00000], -[2037, 0.57429, 0.53274, 0.42945], -[2038, 0.54806, 0.52269, 0.28729], -[2039, 0.76250, 0.00000, 0.30514], -[2040, 0.19689, 0.57500, 0.00000], -[2041, 0.60688, 0.50000, 0.46458], -[2042, 0.60688, 0.03542, 0.00000], -[2043, 0.52165, 0.50000, 0.18750], -[2044, 0.52165, 0.31250, 0.00000], -[2045, 0.52488, 0.53599, 0.26099], -[2046, 0.51765, 0.56973, 0.33414], -[2047, 0.52204, 0.57721, 0.37969], -[2048, 0.00000, 0.75000, 0.25981], -[2049, 0.78750, 0.00000, 0.47835], -[2050, 0.00000, 0.78750, 0.47835], -[2051, 0.55212, 0.54787, 0.37490], -[2052, 0.54330, 0.50000, 0.22500], -[2053, 0.54330, 0.27500, 0.00000], -[2054, 0.50000, 0.56699, 0.27500], -[2055, 0.11029, 0.60000, 0.00000], -[2056, 0.51593, 0.59470, 0.45035], -[2057, 0.53492, 0.55537, 0.33312], -[2058, 0.50000, 0.50000, 0.15000], -[2059, 0.50000, 0.35000, 0.00000], -[2060, 0.55687, 0.55865, 0.47855], -[2061, 0.57167, 0.54399, 0.48829], -[2062, 0.50000, 0.58864, 0.33750], -[2063, 0.41340, 0.45000, 0.00000], -[2064, 0.51182, 0.57121, 0.31173], -[2065, 0.50000, 0.61088, 0.47685], -[2066, 0.60825, 0.50000, 0.43750], -[2067, 0.60825, 0.06250, 0.00000], -[2068, 0.00000, 0.77500, 0.34641], -[2069, 0.00000, 0.78750, 0.43505], -[2070, 0.78750, 0.00000, 0.43505], -[2071, 0.52195, 0.58523, 0.40119], -[2072, 0.58660, 0.50000, 0.32500], -[2073, 0.58660, 0.17500, 0.00000], -[2074, 0.50000, 0.61029, 0.45000], -[2075, 0.51559, 0.56183, 0.29143], -[2076, 0.56495, 0.50000, 0.26250], -[2077, 0.56495, 0.23750, 0.00000], -[2078, 0.60341, 0.51119, 0.48627], -[2079, 0.51785, 0.52137, 0.20722], -[2080, 0.54330, 0.57500, 0.50000], -[2081, 0.55879, 0.55037, 0.39661], -[2082, 0.17524, 0.58750, 0.00000], -[2083, 0.56027, 0.55473, 0.43445], -[2084, 0.68750, 0.00000, 0.10825], -[2085, 0.00000, 0.68750, 0.10825], -[2086, 0.52474, 0.59221, 0.48457], -[2087, 0.54169, 0.57654, 0.47498], -[2088, 0.67500, 0.00000, 0.08660], -[2089, 0.00000, 0.67500, 0.08660], -[2090, 0.70000, 0.00000, 0.12990], -[2091, 0.00000, 0.70000, 0.12990], -[2092, 0.59558, 0.51762, 0.43297], -[2093, 0.04534, 0.61250, 0.00000], -[2094, 0.60825, 0.50000, 0.41250], -[2095, 0.60825, 0.08750, 0.00000], -[2096, 0.51302, 0.60296, 0.46801], -[2097, 0.00000, 0.78750, 0.41136], -[2098, 0.54128, 0.57685, 0.45202], -[2099, 0.50000, 0.61029, 0.42500], -[2100, 0.66250, 0.00000, 0.06495], -[2101, 0.00000, 0.66250, 0.06495], -[2102, 0.47835, 0.38750, 0.00000], -[2103, 0.71250, 0.00000, 0.15155], -[2104, 0.00000, 0.71250, 0.15155], -[2105, 0.00000, 0.76250, 0.28146], -[2106, 0.50000, 0.52369, 0.17500], -[2107, 0.75000, 0.00000, 0.24019], -[2108, 0.50000, 0.54534, 0.21250], -[2109, 0.58620, 0.52175, 0.38040], -[2110, 0.77500, 0.00000, 0.32679], -[2111, 0.43505, 0.43750, 0.00000], -[2112, 0.65000, 0.00000, 0.04330], -[2113, 0.00000, 0.65000, 0.04330], -[2114, 0.50000, 0.58864, 0.31250], -[2115, 0.78750, 0.00000, 0.39175], -[2116, 0.53285, 0.55840, 0.30974], -[2117, 0.30514, 0.53750, 0.00000], -[2118, 0.54407, 0.52251, 0.24870], -[2119, 0.32679, 0.52500, 0.00000], -[2120, 0.72500, 0.00000, 0.17321], -[2121, 0.00000, 0.72500, 0.17321], -[2122, 0.52279, 0.53911, 0.23833], -[2123, 0.50000, 0.61029, 0.40000], -[2124, 0.60825, 0.50000, 0.38750], -[2125, 0.60825, 0.11250, 0.00000], -[2126, 0.58352, 0.52159, 0.35760], -[2127, 0.28349, 0.55000, 0.00000], -[2128, 0.08864, 0.61250, 0.00000], -[2129, 0.15359, 0.60000, 0.00000], -[2130, 0.50000, 0.56699, 0.25000], -[2131, 0.34845, 0.51250, 0.00000], -[2132, 0.58660, 0.50000, 0.30000], -[2133, 0.58660, 0.20000, 0.00000], -[2134, 0.60621, 0.51452, 0.45611], -[2135, 0.57337, 0.53785, 0.37024], -[2136, 0.26184, 0.56250, 0.00000], -[2137, 0.54330, 0.50000, 0.20000], -[2138, 0.54330, 0.30000, 0.00000], -[2139, 0.63750, 0.00000, 0.02165], -[2140, 0.00000, 0.63750, 0.02165], -[2141, 0.54071, 0.57930, 0.41303], -[2142, 0.56495, 0.56250, 0.50000], -[2143, 0.57780, 0.54116, 0.40491], -[2144, 0.52165, 0.50000, 0.16250], -[2145, 0.52165, 0.33750, 0.00000], -[2146, 0.56330, 0.52440, 0.29029], -[2147, 0.54315, 0.56993, 0.37115], -[2148, 0.37010, 0.50000, 0.00000], -[2149, 0.73750, 0.00000, 0.19486], -[2150, 0.00000, 0.73750, 0.19486], -[2151, 0.53888, 0.51284, 0.21073], -[2152, 0.58147, 0.54460, 0.44776], -[2153, 0.00000, 0.78750, 0.36806], -[2154, 0.56495, 0.50000, 0.23750], -[2155, 0.56495, 0.26250, 0.00000], -[2156, 0.50000, 0.61029, 0.37500], -[2157, 0.56650, 0.55704, 0.41712], -[2158, 0.76250, 0.00000, 0.26184], -[2159, 0.24019, 0.57500, 0.00000], -[2160, 0.60825, 0.50000, 0.36250], -[2161, 0.60825, 0.13750, 0.00000], -[2162, 0.54676, 0.53488, 0.26787], -[2163, 0.52279, 0.59971, 0.42115], -[2164, 0.45670, 0.42500, 0.00000], -[2165, 0.00000, 0.77500, 0.30311], -[2166, 0.56139, 0.51785, 0.26304], -[2167, 0.55299, 0.55617, 0.34271], -[2168, 0.80000, 0.00000, 0.50000], -[2169, 0.00000, 0.80000, 0.50000], -[2170, 0.52076, 0.58801, 0.34797], -[2171, 0.56417, 0.56612, 0.45998], -[2172, 0.62500, 0.00000, 0.00000], -[2173, 0.50000, 0.62500, 0.50000], -[2174, 0.62500, 0.50000, 0.50000], -[2175, 0.50000, 0.50000, 0.12500], -[2176, 0.00000, 0.62500, 0.00000], -[2177, 0.50000, 0.37500, 0.00000], -[2178, 0.53423, 0.59521, 0.46388], -[2179, 0.53836, 0.57422, 0.35321], -[2180, 0.39175, 0.48750, 0.00000], -[2181, 0.02369, 0.62500, 0.00000], -[2182, 0.50000, 0.58864, 0.28750], -[2183, 0.80000, 0.00000, 0.45670], -[2184, 0.00000, 0.80000, 0.45670], -[2185, 0.55494, 0.57332, 0.42669], -[2186, 0.59570, 0.52762, 0.40552], -[2187, 0.52898, 0.51370, 0.18619], -[2188, 0.52054, 0.55694, 0.25263], -[2189, 0.13194, 0.61250, 0.00000], -[2190, 0.75000, 0.00000, 0.21651], -[2191, 0.00000, 0.75000, 0.21651], -[2192, 0.21854, 0.58750, 0.00000], -[2193, 0.57919, 0.52781, 0.32998], -[2194, 0.51725, 0.60990, 0.44027], -[2195, 0.78750, 0.00000, 0.34845], -[2196, 0.51825, 0.60427, 0.40192], -[2197, 0.56600, 0.53691, 0.31176], -[2198, 0.54061, 0.58942, 0.43303], -[2199, 0.54187, 0.58199, 0.39026], -[2200, 0.58664, 0.54713, 0.47007], -[2201, 0.58660, 0.50000, 0.27500], -[2202, 0.58660, 0.22500, 0.00000], -[2203, 0.50000, 0.61029, 0.35000], -[2204, 0.50000, 0.54534, 0.18750], -[2205, 0.06699, 0.62500, 0.00000], -[2206, 0.55393, 0.55371, 0.32173], -[2207, 0.60825, 0.50000, 0.33750], -[2208, 0.60825, 0.16250, 0.00000], -[2209, 0.41340, 0.47500, 0.00000], -[2210, 0.58660, 0.55000, 0.50000], -[2211, 0.50000, 0.52369, 0.15000], -[2212, 0.50000, 0.56699, 0.22500], -[2213, 0.52165, 0.61250, 0.50000], -[2214, 0.60327, 0.53178, 0.47561], -[2215, 0.62990, 0.50000, 0.47500], -[2216, 0.62990, 0.02500, 0.00000], -[2217, 0.80000, 0.00000, 0.41340], -[2218, 0.77500, 0.00000, 0.28349], -[2219, 0.51598, 0.53260, 0.18727], -[2220, 0.53265, 0.53625, 0.22302], -[2221, 0.59382, 0.51875, 0.33750], -[2222, 0.59908, 0.53553, 0.45052], -[2223, 0.55719, 0.57339, 0.40330], -[2224, 0.58148, 0.52179, 0.30408], -[2225, 0.19689, 0.60000, 0.00000], -[2226, 0.51265, 0.60644, 0.36484], -[2227, 0.47835, 0.41250, 0.00000], -[2228, 0.50000, 0.63078, 0.46458], -[2229, 0.62990, 0.50000, 0.45000], -[2230, 0.62990, 0.05000, 0.00000], -[2231, 0.00000, 0.76250, 0.23816], -[2232, 0.52065, 0.55077, 0.22434], -[2233, 0.52203, 0.57064, 0.27122], -[2234, 0.56216, 0.56180, 0.36215], -[2235, 0.54330, 0.50000, 0.17500], -[2236, 0.54330, 0.32500, 0.00000], -[2237, 0.51844, 0.54256, 0.20389], -[2238, 0.00000, 0.78750, 0.32476], -[2239, 0.52786, 0.59901, 0.38389], -[2240, 0.52910, 0.58288, 0.32319], -[2241, 0.56495, 0.50000, 0.21250], -[2242, 0.56495, 0.28750, 0.00000], -[2243, 0.61283, 0.51944, 0.41807], -[2244, 0.00000, 0.80000, 0.38971], -[2245, 0.62990, 0.50000, 0.42500], -[2246, 0.62990, 0.07500, 0.00000], -[2247, 0.11029, 0.62500, 0.00000], -[2248, 0.50000, 0.58864, 0.26250], -[2249, 0.50000, 0.61029, 0.32500], -[2250, 0.55473, 0.55218, 0.29884], -[2251, 0.43505, 0.46250, 0.00000], -[2252, 0.50000, 0.63194, 0.43750], -[2253, 0.56468, 0.51678, 0.24034], -[2254, 0.52165, 0.50000, 0.13750], -[2255, 0.52165, 0.36250, 0.00000], -[2256, 0.57806, 0.56486, 0.48232], -[2257, 0.61055, 0.52988, 0.50000], -[2258, 0.58564, 0.55250, 0.42662], -[2259, 0.51468, 0.61872, 0.42193], -[2260, 0.56259, 0.58060, 0.48359], -[2261, 0.58026, 0.54256, 0.34884], -[2262, 0.53753, 0.55851, 0.26809], -[2263, 0.60572, 0.51881, 0.36276], -[2264, 0.60825, 0.50000, 0.31250], -[2265, 0.60825, 0.18750, 0.00000], -[2266, 0.54330, 0.60000, 0.50000], -[2267, 0.51818, 0.58497, 0.28808], -[2268, 0.17524, 0.61250, 0.00000], -[2269, 0.56852, 0.56469, 0.38225], -[2270, 0.51350, 0.62582, 0.47013], -[2271, 0.54702, 0.59746, 0.48282], -[2272, 0.54197, 0.54920, 0.25255], -[2273, 0.58660, 0.50000, 0.25000], -[2274, 0.58660, 0.25000, 0.00000], -[2275, 0.56185, 0.58115, 0.44277], -[2276, 0.62990, 0.50000, 0.40000], -[2277, 0.62990, 0.10000, 0.00000], -[2278, 0.80000, 0.00000, 0.37010], -[2279, 0.58146, 0.51934, 0.27850], -[2280, 0.50000, 0.63194, 0.41250], -[2281, 0.51345, 0.61652, 0.38284], -[2282, 0.54455, 0.57739, 0.33281], -[2283, 0.57414, 0.54731, 0.33055], -[2284, 0.78750, 0.00000, 0.30514], -[2285, 0.00000, 0.77500, 0.25981], -[2286, 0.04534, 0.63750, 0.00000], -[2287, 0.53109, 0.61321, 0.47779], -[2288, 0.61467, 0.51953, 0.39542], -[2289, 0.60309, 0.53827, 0.42717], -[2290, 0.55652, 0.58971, 0.46340], -[2291, 0.61553, 0.52565, 0.43837], -[2292, 0.54633, 0.59797, 0.44456], -[2293, 0.32679, 0.55000, 0.00000], -[2294, 0.57656, 0.56252, 0.39773], -[2295, 0.30514, 0.56250, 0.00000], -[2296, 0.50000, 0.50000, 0.10000], -[2297, 0.50000, 0.40000, 0.00000], -[2298, 0.53908, 0.60029, 0.40386], -[2299, 0.34845, 0.53750, 0.00000], -[2300, 0.62330, 0.52112, 0.47902], -[2301, 0.53661, 0.59487, 0.36310], -[2302, 0.00000, 0.81250, 0.47835], -[2303, 0.81250, 0.00000, 0.47835], -[2304, 0.70000, 0.00000, 0.08660], -[2305, 0.00000, 0.70000, 0.08660], -[2306, 0.28349, 0.57500, 0.00000], -[2307, 0.45670, 0.45000, 0.00000], -[2308, 0.71250, 0.00000, 0.10825], -[2309, 0.00000, 0.71250, 0.10825], -[2310, 0.60131, 0.52579, 0.34796], -[2311, 0.57996, 0.56708, 0.44335], -[2312, 0.50000, 0.54534, 0.16250], -[2313, 0.53617, 0.53190, 0.19821], -[2314, 0.50000, 0.56699, 0.20000], -[2315, 0.68750, 0.00000, 0.06495], -[2316, 0.00000, 0.68750, 0.06495], -[2317, 0.50000, 0.63194, 0.38750], -[2318, 0.55224, 0.53310, 0.23003], -[2319, 0.53744, 0.57236, 0.28628], -[2320, 0.62990, 0.50000, 0.37500], -[2321, 0.62990, 0.12500, 0.00000], -[2322, 0.50000, 0.61029, 0.30000], -[2323, 0.37010, 0.52500, 0.00000], -[2324, 0.72500, 0.00000, 0.12990], -[2325, 0.00000, 0.72500, 0.12990], -[2326, 0.58642, 0.56375, 0.46512], -[2327, 0.56433, 0.51563, 0.21879], -[2328, 0.00000, 0.80000, 0.34641], -[2329, 0.26184, 0.58750, 0.00000], -[2330, 0.67500, 0.00000, 0.04330], -[2331, 0.00000, 0.67500, 0.04330], -[2332, 0.15359, 0.62500, 0.00000], -[2333, 0.08864, 0.63750, 0.00000], -[2334, 0.56495, 0.58750, 0.50000], -[2335, 0.00000, 0.81250, 0.43505], -[2336, 0.81250, 0.00000, 0.43505], -[2337, 0.58936, 0.55152, 0.38636], -[2338, 0.53037, 0.61778, 0.46026], -[2339, 0.56915, 0.53739, 0.27228], -[2340, 0.52932, 0.58745, 0.30131], -[2341, 0.51237, 0.63258, 0.45356], -[2342, 0.50000, 0.52369, 0.12500], -[2343, 0.52615, 0.59926, 0.32966], -[2344, 0.60825, 0.50000, 0.28750], -[2345, 0.60825, 0.21250, 0.00000], -[2346, 0.52172, 0.52367, 0.15521], -[2347, 0.73750, 0.00000, 0.15155], -[2348, 0.00000, 0.73750, 0.15155], -[2349, 0.50000, 0.58864, 0.23750], -[2350, 0.60018, 0.52204, 0.31892], -[2351, 0.39175, 0.51250, 0.00000], -[2352, 0.56169, 0.53713, 0.25057], -[2353, 0.57504, 0.57344, 0.41774], -[2354, 0.51448, 0.63038, 0.43485], -[2355, 0.56495, 0.50000, 0.18750], -[2356, 0.56495, 0.31250, 0.00000], -[2357, 0.54330, 0.50000, 0.15000], -[2358, 0.54330, 0.35000, 0.00000], -[2359, 0.24019, 0.60000, 0.00000], -[2360, 0.66250, 0.00000, 0.02165], -[2361, 0.00000, 0.66250, 0.02165], -[2362, 0.00000, 0.78750, 0.28146], -[2363, 0.00000, 0.81250, 0.41136], -[2364, 0.54195, 0.59050, 0.33979], -[2365, 0.53733, 0.55685, 0.23659], -[2366, 0.50000, 0.63194, 0.36250], -[2367, 0.60232, 0.55267, 0.48586], -[2368, 0.62990, 0.50000, 0.35000], -[2369, 0.62990, 0.15000, 0.00000], -[2370, 0.75000, 0.00000, 0.17321], -[2371, 0.00000, 0.75000, 0.17321], -[2372, 0.58276, 0.55825, 0.36542], -[2373, 0.61975, 0.53269, 0.45981], -[2374, 0.58660, 0.50000, 0.22500], -[2375, 0.58660, 0.27500, 0.00000], -[2376, 0.80000, 0.00000, 0.32679], -[2377, 0.47835, 0.43750, 0.00000], -[2378, 0.55392, 0.53009, 0.21266], -[2379, 0.51826, 0.60473, 0.30962], -[2380, 0.53678, 0.56621, 0.25117], -[2381, 0.56243, 0.58307, 0.38010], -[2382, 0.41340, 0.50000, 0.00000], -[2383, 0.53705, 0.52649, 0.17522], -[2384, 0.59824, 0.54156, 0.35798], -[2385, 0.60671, 0.53905, 0.38640], -[2386, 0.51196, 0.61955, 0.33935], -[2387, 0.59650, 0.51244, 0.26899], -[2388, 0.81250, 0.00000, 0.39175], -[2389, 0.55983, 0.59071, 0.40160], -[2390, 0.58112, 0.54045, 0.29385], -[2391, 0.52165, 0.50000, 0.11250], -[2392, 0.52165, 0.38750, 0.00000], -[2393, 0.65000, 0.00000, 0.00000], -[2394, 0.65000, 0.50000, 0.50000], -[2395, 0.00000, 0.65000, 0.00000], -[2396, 0.50000, 0.65000, 0.50000], -[2397, 0.21854, 0.61250, 0.00000], -[2398, 0.64130, 0.51107, 0.47539], -[2399, 0.02369, 0.65000, 0.00000], -[2400, 0.50000, 0.61029, 0.27500], -[2401, 0.52064, 0.57998, 0.24320], -[2402, 0.51610, 0.63055, 0.40232], -[2403, 0.51728, 0.57420, 0.22360], -[2404, 0.60048, 0.55679, 0.44359], -[2405, 0.13194, 0.63750, 0.00000], -[2406, 0.55923, 0.58130, 0.34749], -[2407, 0.55701, 0.55508, 0.26410], -[2408, 0.51730, 0.62089, 0.35467], -[2409, 0.58843, 0.54153, 0.31353], -[2410, 0.55627, 0.57392, 0.31109], -[2411, 0.76250, 0.00000, 0.19486], -[2412, 0.00000, 0.76250, 0.19486], -[2413, 0.58660, 0.57500, 0.50000], -[2414, 0.63712, 0.51506, 0.43572], -[2415, 0.50000, 0.63194, 0.33750], -[2416, 0.53420, 0.62133, 0.43341], -[2417, 0.65155, 0.50000, 0.46250], -[2418, 0.65155, 0.03750, 0.00000], -[2419, 0.52611, 0.61228, 0.34401], -[2420, 0.56769, 0.56973, 0.32919], -[2421, 0.51054, 0.64435, 0.48032], -[2422, 0.60838, 0.55216, 0.46352], -[2423, 0.60825, 0.50000, 0.26250], -[2424, 0.60825, 0.23750, 0.00000], -[2425, 0.62099, 0.51880, 0.35231], -[2426, 0.52323, 0.62073, 0.36765], -[2427, 0.57339, 0.55862, 0.31058], -[2428, 0.78750, 0.00000, 0.26184], -[2429, 0.43505, 0.48750, 0.00000], -[2430, 0.06699, 0.65000, 0.00000], -[2431, 0.50000, 0.56699, 0.17500], -[2432, 0.57827, 0.58417, 0.45854], -[2433, 0.62990, 0.50000, 0.32500], -[2434, 0.62990, 0.17500, 0.00000], -[2435, 0.00000, 0.81250, 0.36806], -[2436, 0.61544, 0.53880, 0.40759], -[2437, 0.60576, 0.51554, 0.28807], -[2438, 0.60117, 0.55583, 0.41390], -[2439, 0.50000, 0.65359, 0.47500], -[2440, 0.55016, 0.61171, 0.46509], -[2441, 0.52837, 0.62941, 0.44707], -[2442, 0.65155, 0.50000, 0.43750], -[2443, 0.65155, 0.06250, 0.00000], -[2444, 0.53470, 0.62014, 0.41087], -[2445, 0.52165, 0.63750, 0.50000], -[2446, 0.00000, 0.80000, 0.30311], -[2447, 0.50000, 0.54534, 0.13750], -[2448, 0.54337, 0.51728, 0.15904], -[2449, 0.50000, 0.58864, 0.21250], -[2450, 0.51894, 0.60278, 0.28420], -[2451, 0.55057, 0.60232, 0.38408], -[2452, 0.19689, 0.62500, 0.00000], -[2453, 0.55399, 0.52203, 0.18373], -[2454, 0.50000, 0.65359, 0.45000], -[2455, 0.53412, 0.61947, 0.39234], -[2456, 0.50000, 0.50000, 0.07500], -[2457, 0.82500, 0.00000, 0.50000], -[2458, 0.00000, 0.82500, 0.50000], -[2459, 0.50000, 0.42500, 0.00000], -[2460, 0.52442, 0.56489, 0.20557], -[2461, 0.77500, 0.00000, 0.21651], -[2462, 0.00000, 0.77500, 0.21651], -[2463, 0.52009, 0.54631, 0.16500], -[2464, 0.63799, 0.52414, 0.50000], -[2465, 0.57834, 0.56873, 0.34547], -[2466, 0.57677, 0.52743, 0.23331], -[2467, 0.61565, 0.54759, 0.44362], -[2468, 0.59722, 0.53388, 0.29909], -[2469, 0.65155, 0.50000, 0.41250], -[2470, 0.65155, 0.08750, 0.00000], -[2471, 0.54037, 0.55232, 0.20784], -[2472, 0.82500, 0.00000, 0.45670], -[2473, 0.00000, 0.82500, 0.45670], -[2474, 0.62567, 0.53465, 0.42754], -[2475, 0.57360, 0.57931, 0.36530], -[2476, 0.50000, 0.65359, 0.42500], -[2477, 0.56495, 0.50000, 0.16250], -[2478, 0.56495, 0.33750, 0.00000], -[2479, 0.81250, 0.00000, 0.34845], -[2480, 0.58762, 0.52877, 0.25842], -[2481, 0.63286, 0.52405, 0.40866], -[2482, 0.62228, 0.54408, 0.47927], -[2483, 0.55183, 0.61108, 0.42346], -[2484, 0.59936, 0.56958, 0.48810], -[2485, 0.56812, 0.59519, 0.41707], -[2486, 0.52090, 0.64147, 0.46694], -[2487, 0.58660, 0.50000, 0.20000], -[2488, 0.58660, 0.30000, 0.00000], -[2489, 0.45670, 0.47500, 0.00000], -[2490, 0.50000, 0.52369, 0.10000], -[2491, 0.50000, 0.63194, 0.31250], -[2492, 0.11029, 0.65000, 0.00000], -[2493, 0.52333, 0.59320, 0.25723], -[2494, 0.64621, 0.51471, 0.45216], -[2495, 0.57609, 0.58533, 0.39809], -[2496, 0.53397, 0.58974, 0.27201], -[2497, 0.50000, 0.61029, 0.25000], -[2498, 0.54330, 0.50000, 0.12500], -[2499, 0.54330, 0.37500, 0.00000], -[2500, 0.54330, 0.62500, 0.50000], -[2501, 0.55693, 0.57082, 0.27631], -[2502, 0.60825, 0.56250, 0.50000], -[2503, 0.52595, 0.55722, 0.18441], -[2504, 0.62990, 0.50000, 0.30000], -[2505, 0.62990, 0.20000, 0.00000], -[2506, 0.80000, 0.00000, 0.28349], -[2507, 0.51550, 0.52500, 0.11826], -[2508, 0.17524, 0.63750, 0.00000], -[2509, 0.65155, 0.50000, 0.38750], -[2510, 0.65155, 0.11250, 0.00000], -[2511, 0.50000, 0.65359, 0.40000], -[2512, 0.54303, 0.59906, 0.31693], -[2513, 0.32679, 0.57500, 0.00000], -[2514, 0.55284, 0.55247, 0.22310], -[2515, 0.34845, 0.56250, 0.00000], -[2516, 0.51708, 0.54118, 0.14282], -[2517, 0.58547, 0.57520, 0.38075], -[2518, 0.53022, 0.52368, 0.13584], -[2519, 0.82500, 0.00000, 0.41340], -[2520, 0.55128, 0.61971, 0.48659], -[2521, 0.30514, 0.58750, 0.00000], -[2522, 0.59577, 0.57290, 0.42826], -[2523, 0.63359, 0.53316, 0.44789], -[2524, 0.51649, 0.64749, 0.44861], -[2525, 0.78750, 0.00000, 0.23816], -[2526, 0.00000, 0.78750, 0.23816], -[2527, 0.56853, 0.60237, 0.44846], -[2528, 0.62361, 0.51926, 0.32592], -[2529, 0.60825, 0.50000, 0.23750], -[2530, 0.60825, 0.26250, 0.00000], -[2531, 0.54446, 0.62357, 0.43978], -[2532, 0.56039, 0.55452, 0.23935], -[2533, 0.37010, 0.55000, 0.00000], -[2534, 0.60059, 0.57284, 0.46661], -[2535, 0.56919, 0.52990, 0.20807], -[2536, 0.58256, 0.58874, 0.43645], -[2537, 0.56789, 0.60604, 0.47854], -[2538, 0.59916, 0.55558, 0.34957], -[2539, 0.51648, 0.57363, 0.19252], -[2540, 0.28349, 0.60000, 0.00000], -[2541, 0.51889, 0.62420, 0.32192], -[2542, 0.52602, 0.63864, 0.42139], -[2543, 0.00000, 0.81250, 0.32476], -[2544, 0.53250, 0.63819, 0.48914], -[2545, 0.04534, 0.66250, 0.00000], -[2546, 0.59334, 0.57487, 0.40602], -[2547, 0.57474, 0.55886, 0.27820], -[2548, 0.52165, 0.50000, 0.08750], -[2549, 0.52165, 0.41250, 0.00000], -[2550, 0.60929, 0.54031, 0.32914], -[2551, 0.39175, 0.53750, 0.00000], -[2552, 0.47835, 0.46250, 0.00000], -[2553, 0.57156, 0.54129, 0.22966], -[2554, 0.00000, 0.82500, 0.38971], -[2555, 0.54777, 0.59103, 0.29160], -[2556, 0.50000, 0.65359, 0.37500], -[2557, 0.61656, 0.55421, 0.42215], -[2558, 0.65155, 0.50000, 0.36250], -[2559, 0.65155, 0.13750, 0.00000], -[2560, 0.26184, 0.61250, 0.00000], -[2561, 0.50000, 0.56699, 0.15000], -[2562, 0.50000, 0.58864, 0.18750], -[2563, 0.56495, 0.61250, 0.50000], -[2564, 0.56249, 0.59085, 0.32979], -[2565, 0.50000, 0.63194, 0.28750], -[2566, 0.63970, 0.53336, 0.46905], -[2567, 0.52501, 0.63601, 0.37925], -[2568, 0.63508, 0.52478, 0.37085], -[2569, 0.62928, 0.53620, 0.38952], -[2570, 0.66000, 0.51015, 0.48872], -[2571, 0.15359, 0.65000, 0.00000], -[2572, 0.60504, 0.56024, 0.37142], -[2573, 0.41340, 0.52500, 0.00000], -[2574, 0.72500, 0.00000, 0.08660], -[2575, 0.00000, 0.72500, 0.08660], -[2576, 0.08864, 0.66250, 0.00000], -[2577, 0.60402, 0.52928, 0.27239], -[2578, 0.62284, 0.51877, 0.30050], -[2579, 0.71250, 0.00000, 0.06495], -[2580, 0.00000, 0.71250, 0.06495], -[2581, 0.52455, 0.61794, 0.29983], -[2582, 0.55784, 0.60246, 0.34794], -[2583, 0.58121, 0.51590, 0.19440], -[2584, 0.73750, 0.00000, 0.10825], -[2585, 0.00000, 0.73750, 0.10825], -[2586, 0.62990, 0.50000, 0.27500], -[2587, 0.62990, 0.22500, 0.00000], -[2588, 0.54365, 0.63325, 0.46968], -[2589, 0.82500, 0.00000, 0.37010], -[2590, 0.50000, 0.54534, 0.11250], -[2591, 0.00000, 0.80000, 0.25981], -[2592, 0.59916, 0.58011, 0.45079], -[2593, 0.57848, 0.55152, 0.25677], -[2594, 0.53739, 0.53736, 0.15284], -[2595, 0.50000, 0.61029, 0.22500], -[2596, 0.81250, 0.00000, 0.30514], -[2597, 0.24019, 0.62500, 0.00000], -[2598, 0.55153, 0.57808, 0.25499], -[2599, 0.70000, 0.00000, 0.04330], -[2600, 0.00000, 0.70000, 0.04330], -[2601, 0.55149, 0.54464, 0.18681], -[2602, 0.62990, 0.55000, 0.50000], -[2603, 0.75000, 0.00000, 0.12990], -[2604, 0.00000, 0.75000, 0.12990], -[2605, 0.50000, 0.65359, 0.35000], -[2606, 0.59063, 0.56552, 0.32381], -[2607, 0.58660, 0.50000, 0.17500], -[2608, 0.58660, 0.32500, 0.00000], -[2609, 0.62116, 0.51705, 0.28365], -[2610, 0.59162, 0.54669, 0.27301], -[2611, 0.56495, 0.50000, 0.13750], -[2612, 0.56495, 0.36250, 0.00000], -[2613, 0.53667, 0.61656, 0.31985], -[2614, 0.61014, 0.56272, 0.39087], -[2615, 0.59226, 0.51839, 0.21467], -[2616, 0.65155, 0.50000, 0.33750], -[2617, 0.65155, 0.16250, 0.00000], -[2618, 0.53792, 0.58389, 0.23407], -[2619, 0.61278, 0.53156, 0.29213], -[2620, 0.57019, 0.57726, 0.29253], -[2621, 0.68750, 0.00000, 0.02165], -[2622, 0.00000, 0.68750, 0.02165], -[2623, 0.51099, 0.66334, 0.47923], -[2624, 0.83750, 0.00000, 0.47835], -[2625, 0.43505, 0.51250, 0.00000], -[2626, 0.58956, 0.58924, 0.41458], -[2627, 0.64055, 0.51662, 0.34120], -[2628, 0.50000, 0.50000, 0.05000], -[2629, 0.50000, 0.45000, 0.00000], -[2630, 0.60825, 0.50000, 0.21250], -[2631, 0.60825, 0.28750, 0.00000], -[2632, 0.76250, 0.00000, 0.15155], -[2633, 0.00000, 0.76250, 0.15155], -[2634, 0.56158, 0.61311, 0.39196], -[2635, 0.57043, 0.51794, 0.16939], -[2636, 0.61943, 0.54489, 0.35004], -[2637, 0.65073, 0.52864, 0.48125], -[2638, 0.59239, 0.59318, 0.47133], -[2639, 0.55297, 0.62903, 0.45257], -[2640, 0.66195, 0.51022, 0.42759], -[2641, 0.56834, 0.60178, 0.36361], -[2642, 0.67321, 0.50000, 0.47500], -[2643, 0.67321, 0.02500, 0.00000], -[2644, 0.58660, 0.60000, 0.50000], -[2645, 0.21854, 0.63750, 0.00000], -[2646, 0.00000, 0.82500, 0.34641], -[2647, 0.61886, 0.56657, 0.47796], -[2648, 0.53480, 0.64507, 0.44942], -[2649, 0.64729, 0.52315, 0.39015], -[2650, 0.50000, 0.52369, 0.07500], -[2651, 0.52210, 0.59810, 0.22678], -[2652, 0.55518, 0.62293, 0.40628], -[2653, 0.63074, 0.55283, 0.45955], -[2654, 0.59596, 0.55566, 0.29707], -[2655, 0.54330, 0.50000, 0.10000], -[2656, 0.54330, 0.40000, 0.00000], -[2657, 0.83750, 0.00000, 0.43505], -[2658, 0.67500, 0.00000, 0.00000], -[2659, 0.67500, 0.50000, 0.50000], -[2660, 0.50000, 0.67500, 0.50000], -[2661, 0.00000, 0.67500, 0.00000], -[2662, 0.67321, 0.50000, 0.45000], -[2663, 0.67321, 0.05000, 0.00000], -[2664, 0.50000, 0.63194, 0.26250], -[2665, 0.64881, 0.52705, 0.41509], -[2666, 0.65195, 0.52634, 0.43656], -[2667, 0.51962, 0.65363, 0.40569], -[2668, 0.02369, 0.67500, 0.00000], -[2669, 0.13194, 0.66250, 0.00000], -[2670, 0.59541, 0.57623, 0.35887], -[2671, 0.57804, 0.58100, 0.31281], -[2672, 0.60847, 0.52378, 0.25065], -[2673, 0.55451, 0.57293, 0.23344], -[2674, 0.53341, 0.51642, 0.10531], -[2675, 0.51670, 0.59388, 0.20424], -[2676, 0.50000, 0.67524, 0.46250], -[2677, 0.54851, 0.61663, 0.33786], -[2678, 0.00000, 0.77500, 0.17321], -[2679, 0.77500, 0.00000, 0.17321], -[2680, 0.62646, 0.54600, 0.36919], -[2681, 0.52399, 0.56866, 0.16855], -[2682, 0.50000, 0.65359, 0.32500], -[2683, 0.51819, 0.62527, 0.28014], -[2684, 0.00000, 0.81250, 0.28146], -[2685, 0.45670, 0.50000, 0.00000], -[2686, 0.51386, 0.58902, 0.18758], -[2687, 0.56989, 0.53376, 0.18544], -[2688, 0.55623, 0.53636, 0.16592], -[2689, 0.67321, 0.50000, 0.42500], -[2690, 0.67321, 0.07500, 0.00000], -[2691, 0.00000, 0.83750, 0.41136], -[2692, 0.62990, 0.50000, 0.25000], -[2693, 0.62990, 0.25000, 0.00000], -[2694, 0.66315, 0.51820, 0.46720], -[2695, 0.51297, 0.63710, 0.29904], -[2696, 0.62184, 0.55733, 0.38972], -[2697, 0.65155, 0.50000, 0.31250], -[2698, 0.65155, 0.18750, 0.00000], -[2699, 0.50000, 0.67524, 0.43750], -[2700, 0.54153, 0.55384, 0.16828], -[2701, 0.60596, 0.55434, 0.31132], -[2702, 0.06699, 0.67500, 0.00000], -[2703, 0.53686, 0.63310, 0.35425], -[2704, 0.50000, 0.58864, 0.16250], -[2705, 0.57908, 0.59315, 0.34731], -[2706, 0.59055, 0.56780, 0.30165], -[2707, 0.82500, 0.00000, 0.32679], -[2708, 0.66250, 0.52165, 0.50000], -[2709, 0.52165, 0.66250, 0.50000], -[2710, 0.51862, 0.52797, 0.09579], -[2711, 0.57344, 0.61819, 0.48317], -[2712, 0.19689, 0.65000, 0.00000], -[2713, 0.56646, 0.59421, 0.30630], -[2714, 0.53946, 0.64117, 0.40299], -[2715, 0.58442, 0.58501, 0.33318], -[2716, 0.61674, 0.57211, 0.43654], -[2717, 0.51934, 0.64719, 0.34704], -[2718, 0.51928, 0.61978, 0.25870], -[2719, 0.50000, 0.56699, 0.12500], -[2720, 0.62134, 0.51899, 0.26190], -[2721, 0.59948, 0.53079, 0.23357], -[2722, 0.63559, 0.54819, 0.41187], -[2723, 0.50000, 0.61029, 0.20000], -[2724, 0.57323, 0.61334, 0.41178], -[2725, 0.52268, 0.60930, 0.23837], -[2726, 0.83750, 0.00000, 0.39175], -[2727, 0.55684, 0.52663, 0.14539], -[2728, 0.53283, 0.63379, 0.33384], -[2729, 0.67321, 0.50000, 0.40000], -[2730, 0.67321, 0.10000, 0.00000], -[2731, 0.78750, 0.00000, 0.19486], -[2732, 0.00000, 0.78750, 0.19486], -[2733, 0.54746, 0.63140, 0.37794], -[2734, 0.52145, 0.66349, 0.46485], -[2735, 0.55349, 0.62202, 0.35786], -[2736, 0.52165, 0.50000, 0.06250], -[2737, 0.52165, 0.43750, 0.00000], -[2738, 0.50000, 0.67524, 0.41250], -[2739, 0.61970, 0.57277, 0.45715], -[2740, 0.56191, 0.60694, 0.32732], -[2741, 0.53685, 0.58735, 0.21494], -[2742, 0.53834, 0.61474, 0.28330], -[2743, 0.62526, 0.53940, 0.31874], -[2744, 0.55162, 0.57115, 0.20970], -[2745, 0.61088, 0.58405, 0.47574], -[2746, 0.61347, 0.57547, 0.41406], -[2747, 0.63208, 0.53753, 0.33694], -[2748, 0.60825, 0.58750, 0.50000], -[2749, 0.58254, 0.60359, 0.39293], -[2750, 0.62601, 0.56038, 0.40215], -[2751, 0.52069, 0.65751, 0.38608], -[2752, 0.65170, 0.54012, 0.50000], -[2753, 0.51129, 0.67419, 0.47746], -[2754, 0.47835, 0.48750, 0.00000], -[2755, 0.34845, 0.58750, 0.00000], -[2756, 0.58660, 0.50000, 0.15000], -[2757, 0.58660, 0.35000, 0.00000], -[2758, 0.32679, 0.60000, 0.00000], -[2759, 0.81250, 0.00000, 0.26184], -[2760, 0.53044, 0.55887, 0.14880], -[2761, 0.50000, 0.65359, 0.30000], -[2762, 0.58610, 0.54378, 0.22016], -[2763, 0.50000, 0.54534, 0.08750], -[2764, 0.37010, 0.57500, 0.00000], -[2765, 0.60825, 0.50000, 0.18750], -[2766, 0.60825, 0.31250, 0.00000], -[2767, 0.54330, 0.65000, 0.50000], -[2768, 0.65473, 0.53579, 0.45507], -[2769, 0.11029, 0.67500, 0.00000], -[2770, 0.55280, 0.60075, 0.27333], -[2771, 0.64251, 0.52281, 0.32166], -[2772, 0.50000, 0.63194, 0.23750], -[2773, 0.30514, 0.61250, 0.00000], -[2774, 0.60412, 0.59054, 0.43130], -[2775, 0.55075, 0.64017, 0.42648], -[2776, 0.67031, 0.51581, 0.44330], -[2777, 0.50000, 0.67524, 0.38750], -[2778, 0.55021, 0.56356, 0.18647], -[2779, 0.56382, 0.63254, 0.47170], -[2780, 0.00000, 0.83750, 0.36806], -[2781, 0.67321, 0.50000, 0.37500], -[2782, 0.67321, 0.12500, 0.00000], -[2783, 0.63760, 0.55592, 0.44289], -[2784, 0.56495, 0.50000, 0.11250], -[2785, 0.56495, 0.38750, 0.00000], -[2786, 0.00000, 0.82500, 0.30311], -[2787, 0.17524, 0.66250, 0.00000], -[2788, 0.51865, 0.55954, 0.12911], -[2789, 0.65155, 0.50000, 0.28750], -[2790, 0.65155, 0.21250, 0.00000], -[2791, 0.39175, 0.56250, 0.00000], -[2792, 0.63208, 0.53070, 0.30325], -[2793, 0.54238, 0.60180, 0.24773], -[2794, 0.59631, 0.60155, 0.44951], -[2795, 0.80000, 0.00000, 0.21651], -[2796, 0.00000, 0.80000, 0.21651], -[2797, 0.57996, 0.61742, 0.44624], -[2798, 0.52102, 0.65578, 0.36218], -[2799, 0.53095, 0.57810, 0.17682], -[2800, 0.64306, 0.55380, 0.47911], -[2801, 0.64480, 0.54318, 0.40037], -[2802, 0.28349, 0.62500, 0.00000], -[2803, 0.53652, 0.54530, 0.13131], -[2804, 0.61204, 0.56399, 0.33121], -[2805, 0.56709, 0.62887, 0.43205], -[2806, 0.62990, 0.50000, 0.22500], -[2807, 0.62990, 0.27500, 0.00000], -[2808, 0.53432, 0.51430, 0.08472], -[2809, 0.85000, 0.00000, 0.50000], -[2810, 0.00000, 0.85000, 0.50000], -[2811, 0.54109, 0.65511, 0.47622], -[2812, 0.52422, 0.51145, 0.06800], -[2813, 0.51902, 0.65086, 0.32668], -[2814, 0.00000, 0.85000, 0.47631], -[2815, 0.41340, 0.55000, 0.00000], -[2816, 0.61514, 0.51827, 0.22293], -[2817, 0.59050, 0.60819, 0.42737], -[2818, 0.58572, 0.61642, 0.47117], -[2819, 0.53188, 0.63661, 0.31101], -[2820, 0.58887, 0.55555, 0.23793], -[2821, 0.85000, 0.00000, 0.45670], -[2822, 0.83750, 0.00000, 0.34845], -[2823, 0.57120, 0.58994, 0.27551], -[2824, 0.04534, 0.68750, 0.00000], -[2825, 0.65798, 0.52425, 0.36985], -[2826, 0.50000, 0.67524, 0.36250], -[2827, 0.57427, 0.56312, 0.22070], -[2828, 0.61255, 0.55130, 0.28599], -[2829, 0.26184, 0.63750, 0.00000], -[2830, 0.51824, 0.57788, 0.14991], -[2831, 0.52949, 0.54158, 0.11061], -[2832, 0.53245, 0.63227, 0.29442], -[2833, 0.56495, 0.63750, 0.50000], -[2834, 0.50000, 0.50000, 0.02500], -[2835, 0.57609, 0.61476, 0.37393], -[2836, 0.67321, 0.50000, 0.35000], -[2837, 0.67321, 0.15000, 0.00000], -[2838, 0.54330, 0.50000, 0.07500], -[2839, 0.54330, 0.42500, 0.00000], -[2840, 0.57522, 0.62711, 0.45763], -[2841, 0.61030, 0.58141, 0.37506], -[2842, 0.58860, 0.53729, 0.19828], -[2843, 0.59381, 0.56516, 0.26707], -[2844, 0.52233, 0.67026, 0.43477], -[2845, 0.60364, 0.51998, 0.19709], -[2846, 0.64386, 0.53961, 0.35568], -[2847, 0.50000, 0.52369, 0.05000], -[2848, 0.00000, 0.85000, 0.43301], -[2849, 0.62990, 0.57500, 0.50000], -[2850, 0.82500, 0.00000, 0.28349], -[2851, 0.50000, 0.65359, 0.27500], -[2852, 0.51602, 0.59106, 0.16500], -[2853, 0.50000, 0.58864, 0.13750], -[2854, 0.59388, 0.59808, 0.36715], -[2855, 0.50000, 0.61029, 0.17500], -[2856, 0.50056, 0.47708, 0.00000], -[2857, 0.43505, 0.53750, 0.00000], -[2858, 0.61613, 0.58055, 0.39265], -[2859, 0.64722, 0.54278, 0.37813], -[2860, 0.61773, 0.57108, 0.35632], -[2861, 0.81250, 0.00000, 0.23816], -[2862, 0.00000, 0.81250, 0.23816], -[2863, 0.62109, 0.52857, 0.24753], -[2864, 0.53421, 0.59358, 0.19798], -[2865, 0.65123, 0.54665, 0.42213], -[2866, 0.66271, 0.51817, 0.35385], -[2867, 0.15359, 0.67500, 0.00000], -[2868, 0.61054, 0.59593, 0.46083], -[2869, 0.51380, 0.68067, 0.45338], -[2870, 0.54902, 0.62387, 0.30262], -[2871, 0.64022, 0.51876, 0.27496], -[2872, 0.57559, 0.55601, 0.20106], -[2873, 0.85000, 0.00000, 0.41340], -[2874, 0.24019, 0.65000, 0.00000], -[2875, 0.66120, 0.51462, 0.33139], -[2876, 0.56100, 0.64461, 0.48440], -[2877, 0.08864, 0.68750, 0.00000], -[2878, 0.65155, 0.50000, 0.26250], -[2879, 0.65155, 0.23750, 0.00000], -[2880, 0.50000, 0.56699, 0.10000], -[2881, 0.68368, 0.51227, 0.45881], -[2882, 0.58992, 0.51552, 0.15664], -[2883, 0.51647, 0.66780, 0.36171], -[2884, 0.59267, 0.61680, 0.48710], -[2885, 0.63405, 0.56906, 0.42181], -[2886, 0.50000, 0.63194, 0.21250], -[2887, 0.00000, 0.83750, 0.32476], -[2888, 0.50000, 0.67524, 0.33750], -[2889, 0.67283, 0.52881, 0.48490], -[2890, 0.67465, 0.51896, 0.40998], -[2891, 0.52961, 0.67224, 0.48304], -[2892, 0.59286, 0.52714, 0.17812], -[2893, 0.73750, 0.00000, 0.06495], -[2894, 0.00000, 0.73750, 0.06495], -[2895, 0.55032, 0.51368, 0.09175], -[2896, 0.75000, 0.00000, 0.08660], -[2897, 0.00000, 0.75000, 0.08660], -[2898, 0.53991, 0.65280, 0.37443], -[2899, 0.60444, 0.59702, 0.39085], -[2900, 0.67321, 0.50000, 0.32500], -[2901, 0.67321, 0.17500, 0.00000], -[2902, 0.60825, 0.50000, 0.16250], -[2903, 0.60825, 0.33750, 0.00000], -[2904, 0.60544, 0.60580, 0.48093], -[2905, 0.55124, 0.61834, 0.28143], -[2906, 0.56414, 0.62516, 0.34221], -[2907, 0.45670, 0.52500, 0.00000], -[2908, 0.72500, 0.00000, 0.04330], -[2909, 0.00000, 0.72500, 0.04330], -[2910, 0.57932, 0.58136, 0.25332], -[2911, 0.56840, 0.62866, 0.37258], -[2912, 0.62761, 0.53788, 0.27335], -[2913, 0.59371, 0.61708, 0.46350], -[2914, 0.53424, 0.66463, 0.41353], -[2915, 0.00000, 0.85000, 0.38971], -[2916, 0.60669, 0.51063, 0.17464], -[2917, 0.58660, 0.50000, 0.12500], -[2918, 0.58660, 0.37500, 0.00000], -[2919, 0.58660, 0.62500, 0.50000], -[2920, 0.60619, 0.57671, 0.31344], -[2921, 0.76250, 0.00000, 0.10825], -[2922, 0.00000, 0.76250, 0.10825], -[2923, 0.69545, 0.03508, 0.00000], -[2924, 0.55286, 0.63182, 0.32601], -[2925, 0.69571, 0.50000, 0.46458], -[2926, 0.55975, 0.64876, 0.46444], -[2927, 0.60978, 0.58099, 0.33719], -[2928, 0.56395, 0.55710, 0.17207], -[2929, 0.52165, 0.46250, 0.00000], -[2930, 0.65748, 0.51495, 0.30317], -[2931, 0.50000, 0.69689, 0.47500], -[2932, 0.61016, 0.54870, 0.24911], -[2933, 0.71250, 0.00000, 0.02165], -[2934, 0.00000, 0.71250, 0.02165], -[2935, 0.54410, 0.60404, 0.22494], -[2936, 0.68395, 0.51807, 0.47810], -[2937, 0.21854, 0.66250, 0.00000], -[2938, 0.69486, 0.50000, 0.43750], -[2939, 0.69486, 0.06250, 0.00000], -[2940, 0.60614, 0.53420, 0.21023], -[2941, 0.62990, 0.50000, 0.20000], -[2942, 0.62990, 0.30000, 0.00000], -[2943, 0.56557, 0.61558, 0.30468], -[2944, 0.51823, 0.61129, 0.19215], -[2945, 0.51355, 0.62997, 0.22341], -[2946, 0.61988, 0.59178, 0.44795], -[2947, 0.59111, 0.59101, 0.30366], -[2948, 0.56139, 0.53187, 0.12667], -[2949, 0.56012, 0.59639, 0.23909], -[2950, 0.77500, 0.00000, 0.12990], -[2951, 0.00000, 0.77500, 0.12990], -[2952, 0.55887, 0.58984, 0.22172], -[2953, 0.56340, 0.60099, 0.25695], -[2954, 0.66928, 0.53338, 0.42703], -[2955, 0.50000, 0.69689, 0.45000], -[2956, 0.53472, 0.60708, 0.21065], -[2957, 0.52333, 0.67334, 0.39529], -[2958, 0.00000, 0.82500, 0.25981], -[2959, 0.55002, 0.64059, 0.34044], -[2960, 0.52221, 0.50000, 0.03542], -[2961, 0.51175, 0.57317, 0.11481], -[2962, 0.50000, 0.54534, 0.06250], -[2963, 0.63094, 0.57173, 0.38101], -[2964, 0.57769, 0.63094, 0.41361], -[2965, 0.56495, 0.50000, 0.08750], -[2966, 0.56495, 0.41250, 0.00000], -[2967, 0.83750, 0.00000, 0.30514], -[2968, 0.85000, 0.00000, 0.37010], -[2969, 0.50000, 0.65359, 0.25000], -[2970, 0.63586, 0.57892, 0.47761], -[2971, 0.65462, 0.53471, 0.34017], -[2972, 0.70000, 0.00000, 0.00000], -[2973, 0.70000, 0.50000, 0.50000], -[2974, 0.50000, 0.70000, 0.50000], -[2975, 0.00000, 0.70000, 0.00000], -[2976, 0.58019, 0.62633, 0.39445], -[2977, 0.13194, 0.68750, 0.00000], -[2978, 0.55266, 0.55522, 0.14429], -[2979, 0.51102, 0.55743, 0.08946], -[2980, 0.60207, 0.57736, 0.28879], -[2981, 0.69486, 0.50000, 0.41250], -[2982, 0.69486, 0.08750, 0.00000], -[2983, 0.02369, 0.70000, 0.00000], -[2984, 0.56498, 0.64162, 0.40146], -[2985, 0.50000, 0.67524, 0.31250], -[2986, 0.58905, 0.60658, 0.33783], -[2987, 0.66137, 0.54821, 0.44267], -[2988, 0.67785, 0.51962, 0.39166], -[2989, 0.50000, 0.69689, 0.42500], -[2990, 0.47835, 0.51250, 0.00000], -[2991, 0.00000, 0.78750, 0.15155], -[2992, 0.78750, 0.00000, 0.15155], -[2993, 0.53996, 0.53380, 0.09361], -[2994, 0.65312, 0.56152, 0.50000], -[2995, 0.58197, 0.60794, 0.31620], -[2996, 0.56475, 0.64738, 0.43466], -[2997, 0.53789, 0.63336, 0.27202], -[2998, 0.58170, 0.52800, 0.14591], -[2999, 0.57397, 0.58357, 0.22958], -[3000, 0.67321, 0.50000, 0.30000], -[3001, 0.67321, 0.20000, 0.00000], -[3002, 0.65155, 0.50000, 0.23750], -[3003, 0.65155, 0.26250, 0.00000], -[3004, 0.86250, 0.00000, 0.47835], -[3005, 0.19689, 0.67500, 0.00000], -[3006, 0.06699, 0.70000, 0.00000], -[3007, 0.53135, 0.60188, 0.18370], -[3008, 0.55700, 0.64441, 0.36159], -[3009, 0.63084, 0.56610, 0.33792], -[3010, 0.68750, 0.52165, 0.50000], -[3011, 0.52165, 0.68750, 0.50000], -[3012, 0.50000, 0.61029, 0.15000], -[3013, 0.52244, 0.62420, 0.21288], -[3014, 0.60825, 0.61250, 0.50000], -[3015, 0.51591, 0.53012, 0.05504], -[3016, 0.53389, 0.65619, 0.32772], -[3017, 0.63791, 0.57886, 0.44223], -[3018, 0.52101, 0.68325, 0.41588], -[3019, 0.53820, 0.62304, 0.24008], -[3020, 0.69486, 0.50000, 0.38750], -[3021, 0.69486, 0.11250, 0.00000], -[3022, 0.55063, 0.61995, 0.25913], -[3023, 0.55064, 0.53659, 0.10694], -[3024, 0.50000, 0.69689, 0.40000], -[3025, 0.67730, 0.53433, 0.45902], -[3026, 0.53186, 0.62186, 0.22372], -[3027, 0.62643, 0.58996, 0.42611], -[3028, 0.00000, 0.86250, 0.45466], -[3029, 0.00000, 0.85000, 0.34641], -[3030, 0.34845, 0.61250, 0.00000], -[3031, 0.50000, 0.58864, 0.11250], -[3032, 0.66309, 0.55302, 0.46511], -[3033, 0.00000, 0.80000, 0.17321], -[3034, 0.80000, 0.00000, 0.17321], -[3035, 0.53484, 0.66280, 0.35341], -[3036, 0.62902, 0.56084, 0.30839], -[3037, 0.58401, 0.61878, 0.34842], -[3038, 0.51834, 0.66337, 0.30458], -[3039, 0.37010, 0.60000, 0.00000], -[3040, 0.50000, 0.63194, 0.18750], -[3041, 0.66687, 0.53695, 0.38135], -[3042, 0.59489, 0.55997, 0.21769], -[3043, 0.61333, 0.59233, 0.35776], -[3044, 0.56738, 0.52088, 0.10742], -[3045, 0.32679, 0.62500, 0.00000], -[3046, 0.66631, 0.55069, 0.48526], -[3047, 0.54330, 0.50000, 0.05000], -[3048, 0.54330, 0.45000, 0.00000], -[3049, 0.52880, 0.54372, 0.08464], -[3050, 0.66703, 0.54246, 0.40606], -[3051, 0.86250, 0.00000, 0.43505], -[3052, 0.57953, 0.60796, 0.29336], -[3053, 0.55127, 0.66359, 0.43687], -[3054, 0.84719, 0.00000, 0.32509], -[3055, 0.39175, 0.58750, 0.00000], -[3056, 0.65734, 0.52212, 0.28989], -[3057, 0.57143, 0.62678, 0.32750], -[3058, 0.00000, 0.83750, 0.28146], -[3059, 0.30514, 0.63750, 0.00000], -[3060, 0.55403, 0.58712, 0.18662], -[3061, 0.50000, 0.52369, 0.02500], -[3062, 0.58715, 0.63600, 0.47456], -[3063, 0.50000, 0.50000, 0.00000], -[3064, 0.60281, 0.61515, 0.40724], -[3065, 0.52770, 0.68653, 0.47028], -[3066, 0.52669, 0.66856, 0.33761], -[3067, 0.67500, 0.54330, 0.50000], -[3068, 0.54330, 0.67500, 0.50000], -[3069, 0.53999, 0.56794, 0.13000], -[3070, 0.50000, 0.67524, 0.28750], -[3071, 0.68678, 0.52486, 0.43643], -[3072, 0.58927, 0.51509, 0.12761], -[3073, 0.52375, 0.63483, 0.22808], -[3074, 0.61761, 0.56157, 0.26661], -[3075, 0.50000, 0.69689, 0.37500], -[3076, 0.54171, 0.52462, 0.07263], -[3077, 0.52980, 0.63886, 0.24995], -[3078, 0.60825, 0.50000, 0.13750], -[3079, 0.60825, 0.36250, 0.00000], -[3080, 0.54977, 0.66898, 0.46011], -[3081, 0.57120, 0.58583, 0.21369], -[3082, 0.57037, 0.61289, 0.27531], -[3083, 0.41340, 0.57500, 0.00000], -[3084, 0.69486, 0.50000, 0.36250], -[3085, 0.69486, 0.13750, 0.00000], -[3086, 0.00000, 0.86250, 0.41136], -[3087, 0.60276, 0.57043, 0.24856], -[3088, 0.55814, 0.59441, 0.20478], -[3089, 0.62453, 0.51400, 0.18731], -[3090, 0.50000, 0.56699, 0.07500], -[3091, 0.11029, 0.70000, 0.00000], -[3092, 0.62990, 0.50000, 0.17500], -[3093, 0.62990, 0.32500, 0.00000], -[3094, 0.50000, 0.65359, 0.22500], -[3095, 0.58773, 0.63551, 0.44045], -[3096, 0.54143, 0.59073, 0.16723], -[3097, 0.28349, 0.65000, 0.00000], -[3098, 0.53649, 0.68017, 0.44989], -[3099, 0.81250, 0.00000, 0.19486], -[3100, 0.00000, 0.81250, 0.19486], -[3101, 0.17524, 0.68750, 0.00000], -[3102, 0.54240, 0.67735, 0.48071], -[3103, 0.51979, 0.60153, 0.15130], -[3104, 0.67321, 0.50000, 0.27500], -[3105, 0.67321, 0.22500, 0.00000], -[3106, 0.59901, 0.58370, 0.26693], -[3107, 0.53423, 0.67264, 0.37352], -[3108, 0.62053, 0.60028, 0.40681], -[3109, 0.58660, 0.50000, 0.10000], -[3110, 0.58660, 0.40000, 0.00000], -[3111, 0.65452, 0.56688, 0.43191], -[3112, 0.57373, 0.65014, 0.44913], -[3113, 0.59808, 0.55688, 0.20560], -[3114, 0.59780, 0.61975, 0.38478], -[3115, 0.51443, 0.70000, 0.48125], -[3116, 0.65639, 0.56757, 0.45316], -[3117, 0.56425, 0.65067, 0.38256], -[3118, 0.60187, 0.62478, 0.44520], -[3119, 0.86250, 0.00000, 0.39175], -[3120, 0.60767, 0.51480, 0.15161], -[3121, 0.43505, 0.56250, 0.00000], -[3122, 0.60469, 0.59848, 0.32060], -[3123, 0.62734, 0.60167, 0.47539], -[3124, 0.56945, 0.65241, 0.42018], -[3125, 0.61258, 0.60378, 0.37048], -[3126, 0.56160, 0.66396, 0.48155], -[3127, 0.62990, 0.60000, 0.50000], -[3128, 0.53126, 0.56083, 0.09976], -[3129, 0.59081, 0.55506, 0.18389], -[3130, 0.65155, 0.50000, 0.21250], -[3131, 0.65155, 0.28750, 0.00000], -[3132, 0.51742, 0.68789, 0.37206], -[3133, 0.59308, 0.57607, 0.22852], -[3134, 0.26184, 0.66250, 0.00000], -[3135, 0.53374, 0.65278, 0.28408], -[3136, 0.63190, 0.54685, 0.25628], -[3137, 0.65296, 0.55568, 0.34935], -[3138, 0.54859, 0.57783, 0.14914], -[3139, 0.56495, 0.66250, 0.50000], -[3140, 0.52311, 0.69315, 0.43649], -[3141, 0.62650, 0.59376, 0.38559], -[3142, 0.50000, 0.69689, 0.35000], -[3143, 0.55563, 0.55349, 0.12160], -[3144, 0.65114, 0.55079, 0.32418], -[3145, 0.69953, 0.51365, 0.42739], -[3146, 0.53365, 0.68815, 0.48469], -[3147, 0.60961, 0.56015, 0.22921], -[3148, 0.58113, 0.54927, 0.15454], -[3149, 0.54838, 0.66785, 0.38956], -[3150, 0.57933, 0.55870, 0.16633], -[3151, 0.65857, 0.57024, 0.48186], -[3152, 0.69486, 0.50000, 0.33750], -[3153, 0.69486, 0.16250, 0.00000], -[3154, 0.51867, 0.61778, 0.17026], -[3155, 0.52465, 0.59047, 0.13177], -[3156, 0.63932, 0.57447, 0.35571], -[3157, 0.65315, 0.56999, 0.40920], -[3158, 0.53800, 0.65986, 0.31303], -[3159, 0.53271, 0.53833, 0.06837], -[3160, 0.56495, 0.50000, 0.06250], -[3161, 0.56495, 0.43750, 0.00000], -[3162, 0.67866, 0.51651, 0.31740], -[3163, 0.66902, 0.54108, 0.35679], -[3164, 0.64587, 0.53261, 0.25492], -[3165, 0.82500, 0.00000, 0.21651], -[3166, 0.00000, 0.82500, 0.21651], -[3167, 0.45670, 0.55000, 0.00000], -[3168, 0.55290, 0.64071, 0.28811], -[3169, 0.56175, 0.61523, 0.24100], -[3170, 0.00000, 0.85000, 0.30311], -[3171, 0.00000, 0.86250, 0.36806], -[3172, 0.57993, 0.59906, 0.24286], -[3173, 0.65981, 0.55633, 0.37126], -[3174, 0.66642, 0.53416, 0.32077], -[3175, 0.69025, 0.52640, 0.40977], -[3176, 0.62417, 0.57422, 0.29417], -[3177, 0.71495, 0.02300, 0.00000], -[3178, 0.58572, 0.60184, 0.26228], -[3179, 0.64885, 0.58291, 0.46372], -[3180, 0.62710, 0.54600, 0.23384], -[3181, 0.61560, 0.61805, 0.46438], -[3182, 0.63357, 0.55762, 0.27668], -[3183, 0.50000, 0.67524, 0.26250], -[3184, 0.60941, 0.54348, 0.19078], -[3185, 0.54082, 0.68171, 0.42739], -[3186, 0.68301, 0.54327, 0.46910], -[3187, 0.64616, 0.57513, 0.37983], -[3188, 0.67622, 0.52874, 0.33907], -[3189, 0.54880, 0.65985, 0.33781], -[3190, 0.54493, 0.60889, 0.19131], -[3191, 0.62591, 0.53189, 0.20277], -[3192, 0.50000, 0.61029, 0.12500], -[3193, 0.50000, 0.63194, 0.16250], -[3194, 0.24019, 0.67500, 0.00000], -[3195, 0.68822, 0.51855, 0.35579], -[3196, 0.51106, 0.70368, 0.41597], -[3197, 0.56630, 0.64660, 0.34300], -[3198, 0.51918, 0.66245, 0.26517], -[3199, 0.15359, 0.70000, 0.00000], -[3200, 0.64327, 0.55422, 0.29315], -[3201, 0.56963, 0.60216, 0.22307], -[3202, 0.65032, 0.53934, 0.27642], -[3203, 0.63290, 0.58711, 0.36314], -[3204, 0.71651, 0.50000, 0.47500], -[3205, 0.66171, 0.52158, 0.26736], -[3206, 0.57824, 0.57815, 0.19107], -[3207, 0.50000, 0.54611, 0.03542], -[3208, 0.59851, 0.59945, 0.28363], -[3209, 0.52672, 0.68247, 0.35359], -[3210, 0.54236, 0.51874, 0.05107], -[3211, 0.55881, 0.63154, 0.26809], -[3212, 0.58594, 0.63928, 0.38639], -[3213, 0.69535, 0.53016, 0.47436], -[3214, 0.51768, 0.68214, 0.32104], -[3215, 0.61193, 0.60362, 0.33705], -[3216, 0.57066, 0.62756, 0.28535], -[3217, 0.87500, 0.00000, 0.50000], -[3218, 0.00000, 0.87500, 0.50000], -[3219, 0.67321, 0.50000, 0.25000], -[3220, 0.67321, 0.25000, 0.00000], -[3221, 0.63007, 0.58737, 0.34585], -[3222, 0.64025, 0.58890, 0.40473], -[3223, 0.62190, 0.61178, 0.43102], -[3224, 0.71651, 0.50000, 0.45000], -[3225, 0.71651, 0.05000, 0.00000], -[3226, 0.56235, 0.51482, 0.07026], -[3227, 0.57434, 0.51746, 0.08966], -[3228, 0.00000, 0.87500, 0.47631], -[3229, 0.61219, 0.53387, 0.17371], -[3230, 0.50000, 0.69689, 0.32500], -[3231, 0.67198, 0.55591, 0.42394], -[3232, 0.58158, 0.53522, 0.12354], -[3233, 0.60689, 0.63053, 0.47624], -[3234, 0.58660, 0.65000, 0.50000], -[3235, 0.50000, 0.58864, 0.08750], -[3236, 0.64465, 0.52869, 0.23232], -[3237, 0.59073, 0.57675, 0.20814], -[3238, 0.50000, 0.65359, 0.20000], -[3239, 0.68651, 0.52894, 0.37254], -[3240, 0.87500, 0.00000, 0.45670], -[3241, 0.47835, 0.53750, 0.00000], -[3242, 0.69486, 0.50000, 0.31250], -[3243, 0.69486, 0.18750, 0.00000], -[3244, 0.59098, 0.63362, 0.36824], -[3245, 0.56560, 0.64171, 0.30871], -[3246, 0.56517, 0.66243, 0.39950], -[3247, 0.52263, 0.69623, 0.39701], -[3248, 0.65847, 0.54228, 0.29781], -[3249, 0.52474, 0.50921, 0.01631], -[3250, 0.71651, 0.50000, 0.42500], -[3251, 0.71651, 0.07500, 0.00000], -[3252, 0.61361, 0.59377, 0.29997], -[3253, 0.50000, 0.71962, 0.46458], -[3254, 0.63202, 0.60634, 0.45340], -[3255, 0.51312, 0.51472, 0.00904], -[3256, 0.56492, 0.64901, 0.32993], -[3257, 0.62990, 0.50000, 0.15000], -[3258, 0.62990, 0.35000, 0.00000], -[3259, 0.51860, 0.57880, 0.09312], -[3260, 0.55931, 0.61210, 0.21357], -[3261, 0.64714, 0.59206, 0.48139], -[3262, 0.65155, 0.58750, 0.50000], -[3263, 0.60090, 0.53761, 0.15406], -[3264, 0.00000, 0.83750, 0.23816], -[3265, 0.83750, 0.00000, 0.23816], -[3266, 0.64777, 0.58700, 0.42351], -[3267, 0.52116, 0.64208, 0.20642], -[3268, 0.00000, 0.87500, 0.43301], -[3269, 0.60825, 0.50000, 0.11250], -[3270, 0.60825, 0.38750, 0.00000], -[3271, 0.50000, 0.71854, 0.43750], -[3272, 0.21854, 0.68750, 0.00000], -[3273, 0.54411, 0.62397, 0.20826], -[3274, 0.51315, 0.59612, 0.11030], -[3275, 0.76250, 0.00000, 0.06495], -[3276, 0.00000, 0.76250, 0.06495], -[3277, 0.54330, 0.50000, 0.02500], -[3278, 0.54330, 0.47500, 0.00000], -[3279, 0.75000, 0.00000, 0.04330], -[3280, 0.00000, 0.75000, 0.04330], -[3281, 0.58783, 0.59191, 0.22515], -[3282, 0.77500, 0.00000, 0.08660], -[3283, 0.00000, 0.77500, 0.08660], -[3284, 0.55756, 0.66628, 0.36857], -[3285, 0.67072, 0.55722, 0.39144], -[3286, 0.65155, 0.50000, 0.18750], -[3287, 0.65155, 0.31250, 0.00000], -[3288, 0.58329, 0.62767, 0.30452], -[3289, 0.62171, 0.62108, 0.48630], -[3290, 0.57553, 0.55372, 0.13301], -[3291, 0.57575, 0.57381, 0.16564], -[3292, 0.51971, 0.55274, 0.05609], -[3293, 0.73750, 0.00000, 0.02165], -[3294, 0.00000, 0.73750, 0.02165], -[3295, 0.59942, 0.55279, 0.17122], -[3296, 0.58754, 0.52274, 0.10690], -[3297, 0.87500, 0.00000, 0.41340], -[3298, 0.56012, 0.53405, 0.08261], -[3299, 0.58136, 0.65195, 0.39926], -[3300, 0.71651, 0.50000, 0.40000], -[3301, 0.71651, 0.10000, 0.00000], -[3302, 0.78750, 0.00000, 0.10825], -[3303, 0.00000, 0.78750, 0.10825], -[3304, 0.60009, 0.61212, 0.30271], -[3305, 0.50000, 0.71854, 0.41250], -[3306, 0.50000, 0.56699, 0.05000], -[3307, 0.57471, 0.54007, 0.10953], -[3308, 0.56764, 0.67109, 0.45628], -[3309, 0.00000, 0.86250, 0.32476], -[3310, 0.58660, 0.50000, 0.07500], -[3311, 0.58660, 0.42500, 0.00000], -[3312, 0.50000, 0.67524, 0.23750], -[3313, 0.63040, 0.58542, 0.31322], -[3314, 0.53165, 0.52167, 0.03071], -[3315, 0.13194, 0.71250, 0.00000], -[3316, 0.67664, 0.52702, 0.30132], -[3317, 0.62650, 0.52118, 0.16691], -[3318, 0.59916, 0.59296, 0.24591], -[3319, 0.56069, 0.67410, 0.41876], -[3320, 0.57536, 0.56805, 0.15095], -[3321, 0.72500, 0.50000, 0.50000], -[3322, 0.50000, 0.52500, 0.00000], -[3323, 0.72500, 0.00000, 0.00000], -[3324, 0.52500, 0.50000, 0.00000], -[3325, 0.00000, 0.72500, 0.00000], -[3326, 0.50000, 0.72500, 0.50000], -[3327, 0.62501, 0.56580, 0.24528], -[3328, 0.50000, 0.69689, 0.30000], -[3329, 0.68674, 0.54078, 0.39221], -[3330, 0.54362, 0.68645, 0.40422], -[3331, 0.70053, 0.52261, 0.38959], -[3332, 0.68690, 0.51240, 0.29577], -[3333, 0.64078, 0.60158, 0.43960], -[3334, 0.59554, 0.62486, 0.32374], -[3335, 0.52329, 0.67383, 0.28007], -[3336, 0.57513, 0.62053, 0.25418], -[3337, 0.56329, 0.66149, 0.35346], -[3338, 0.53554, 0.69042, 0.38650], -[3339, 0.58347, 0.65975, 0.47422], -[3340, 0.60825, 0.63750, 0.50000], -[3341, 0.86585, 0.00000, 0.33660], -[3342, 0.53847, 0.60993, 0.16169], -[3343, 0.69465, 0.51606, 0.33389], -[3344, 0.68004, 0.51651, 0.28254], -[3345, 0.80000, 0.00000, 0.12990], -[3346, 0.00000, 0.80000, 0.12990], -[3347, 0.53338, 0.58243, 0.10824], -[3348, 0.04330, 0.72500, 0.00000], -[3349, 0.63700, 0.60443, 0.41990], -[3350, 0.37010, 0.62500, 0.00000], -[3351, 0.60655, 0.63612, 0.42871], -[3352, 0.00000, 0.87500, 0.38971], -[3353, 0.53756, 0.62251, 0.18170], -[3354, 0.34845, 0.63750, 0.00000], -[3355, 0.62078, 0.55409, 0.20768], -[3356, 0.51687, 0.61206, 0.13111], -[3357, 0.60079, 0.63822, 0.40200], -[3358, 0.69486, 0.50000, 0.28750], -[3359, 0.69486, 0.21250, 0.00000], -[3360, 0.52882, 0.56552, 0.07741], -[3361, 0.60780, 0.52434, 0.13402], -[3362, 0.52553, 0.66015, 0.24247], -[3363, 0.66241, 0.51173, 0.22123], -[3364, 0.51711, 0.68590, 0.29859], -[3365, 0.56691, 0.60144, 0.19120], -[3366, 0.39175, 0.61250, 0.00000], -[3367, 0.70989, 0.52233, 0.45639], -[3368, 0.19689, 0.70000, 0.00000], -[3369, 0.59081, 0.65118, 0.42444], -[3370, 0.51530, 0.54497, 0.03494], -[3371, 0.67321, 0.50000, 0.22500], -[3372, 0.67321, 0.27500, 0.00000], -[3373, 0.56230, 0.57245, 0.13259], -[3374, 0.67340, 0.56767, 0.44364], -[3375, 0.50000, 0.71854, 0.38750], -[3376, 0.71651, 0.50000, 0.37500], -[3377, 0.71651, 0.12500, 0.00000], -[3378, 0.61835, 0.58938, 0.27793], -[3379, 0.62137, 0.61757, 0.39234], -[3380, 0.32679, 0.65000, 0.00000], -[3381, 0.59908, 0.64741, 0.46277], -[3382, 0.59545, 0.64910, 0.43932], -[3383, 0.71250, 0.52165, 0.50000], -[3384, 0.52165, 0.71250, 0.50000], -[3385, 0.67082, 0.55040, 0.33592], -[3386, 0.64779, 0.52545, 0.20981], -[3387, 0.55100, 0.57282, 0.11487], -[3388, 0.55643, 0.63639, 0.24419], -[3389, 0.00000, 0.85000, 0.25981], -[3390, 0.85000, 0.00000, 0.25981], -[3391, 0.57612, 0.60159, 0.20593], -[3392, 0.54040, 0.64042, 0.21985], -[3393, 0.50000, 0.63194, 0.13750], -[3394, 0.69419, 0.54517, 0.45913], -[3395, 0.41340, 0.60000, 0.00000], -[3396, 0.59162, 0.54529, 0.13451], -[3397, 0.62520, 0.51019, 0.13898], -[3398, 0.65815, 0.55915, 0.31104], -[3399, 0.00000, 0.81250, 0.15155], -[3400, 0.81250, 0.00000, 0.15155], -[3401, 0.70222, 0.53709, 0.48613], -[3402, 0.67993, 0.56463, 0.47247], -[3403, 0.55771, 0.55697, 0.09914], -[3404, 0.65956, 0.58629, 0.44309], -[3405, 0.30514, 0.66250, 0.00000], -[3406, 0.57578, 0.66813, 0.43501], -[3407, 0.50000, 0.61029, 0.10000], -[3408, 0.87500, 0.00000, 0.37010], -[3409, 0.50000, 0.65359, 0.17500], -[3410, 0.69139, 0.54891, 0.44074], -[3411, 0.59075, 0.64061, 0.34618], -[3412, 0.08660, 0.72500, 0.00000], -[3413, 0.53481, 0.53905, 0.04552], -[3414, 0.64629, 0.55498, 0.26010], -[3415, 0.60840, 0.62633, 0.35491], -[3416, 0.55858, 0.68609, 0.47082], -[3417, 0.53802, 0.68172, 0.32748], -[3418, 0.55165, 0.60940, 0.17058], -[3419, 0.64908, 0.60156, 0.46801], -[3420, 0.62609, 0.62034, 0.41385], -[3421, 0.65782, 0.57683, 0.36243], -[3422, 0.43505, 0.58750, 0.00000], -[3423, 0.53429, 0.70181, 0.41841], -[3424, 0.62798, 0.60796, 0.35580], -[3425, 0.55308, 0.54716, 0.07624], -[3426, 0.63524, 0.53020, 0.18314], -[3427, 0.70000, 0.54330, 0.50000], -[3428, 0.54330, 0.70000, 0.50000], -[3429, 0.50000, 0.71854, 0.36250], -[3430, 0.52020, 0.69850, 0.33591], -[3431, 0.61874, 0.58548, 0.25531], -[3432, 0.60153, 0.65093, 0.48533], -[3433, 0.66482, 0.52711, 0.24318], -[3434, 0.68223, 0.55150, 0.37241], -[3435, 0.71651, 0.50000, 0.35000], -[3436, 0.71651, 0.15000, 0.00000], -[3437, 0.55017, 0.65524, 0.26787], -[3438, 0.51655, 0.71319, 0.39768], -[3439, 0.28349, 0.67500, 0.00000], -[3440, 0.64952, 0.57694, 0.32271], -[3441, 0.59933, 0.53242, 0.12113], -[3442, 0.66849, 0.57764, 0.42466], -[3443, 0.50000, 0.69689, 0.27500], -[3444, 0.56031, 0.68457, 0.43920], -[3445, 0.70353, 0.53556, 0.43140], -[3446, 0.53155, 0.63886, 0.18985], -[3447, 0.54711, 0.59027, 0.12697], -[3448, 0.54389, 0.64873, 0.23474], -[3449, 0.56670, 0.46473, 0.00000], -[3450, 0.66869, 0.58289, 0.48514], -[3451, 0.61134, 0.57467, 0.21151], -[3452, 0.62990, 0.62500, 0.50000], -[3453, 0.62990, 0.50000, 0.12500], -[3454, 0.62990, 0.37500, 0.00000], -[3455, 0.00000, 0.82500, 0.17321], -[3456, 0.82500, 0.00000, 0.17321], -[3457, 0.59330, 0.62390, 0.28421], -[3458, 0.53292, 0.70857, 0.45741], -[3459, 0.50000, 0.58864, 0.06250], -[3460, 0.52517, 0.62374, 0.14906], -[3461, 0.88750, 0.00000, 0.47835], -[3462, 0.61476, 0.58222, 0.23293], -[3463, 0.17524, 0.71250, 0.00000], -[3464, 0.65155, 0.50000, 0.16250], -[3465, 0.65155, 0.33750, 0.00000], -[3466, 0.67269, 0.53659, 0.28083], -[3467, 0.63591, 0.61149, 0.39882], -[3468, 0.50000, 0.67524, 0.21250], -[3469, 0.64634, 0.57547, 0.30002], -[3470, 0.56425, 0.50000, 0.03036], -[3471, 0.62216, 0.52938, 0.15122], -[3472, 0.59451, 0.57416, 0.17458], -[3473, 0.58022, 0.61690, 0.23197], -[3474, 0.45670, 0.57500, 0.00000], -[3475, 0.00000, 0.87500, 0.34641], -[3476, 0.69486, 0.50000, 0.26250], -[3477, 0.69486, 0.23750, 0.00000], -[3478, 0.53806, 0.60772, 0.13884], -[3479, 0.71734, 0.52072, 0.43968], -[3480, 0.54631, 0.67043, 0.29634], -[3481, 0.00000, 0.88750, 0.45466], -[3482, 0.69306, 0.55008, 0.41702], -[3483, 0.51428, 0.70104, 0.31561], -[3484, 0.57074, 0.67047, 0.37863], -[3485, 0.64910, 0.59576, 0.38247], -[3486, 0.60825, 0.50000, 0.08750], -[3487, 0.60825, 0.41250, 0.00000], -[3488, 0.64804, 0.58771, 0.34213], -[3489, 0.69298, 0.55682, 0.48530], -[3490, 0.68233, 0.57003, 0.50000], -[3491, 0.51443, 0.72500, 0.48125], -[3492, 0.58480, 0.65582, 0.36211], -[3493, 0.26184, 0.68750, 0.00000], -[3494, 0.60851, 0.60433, 0.26354], -[3495, 0.00000, 0.86250, 0.28146], -[3496, 0.86250, 0.00000, 0.28146], -[3497, 0.56281, 0.63192, 0.22504], -[3498, 0.56495, 0.68750, 0.50000], -[3499, 0.54447, 0.70120, 0.43898], -[3500, 0.88750, 0.00000, 0.43505], -[3501, 0.58572, 0.64513, 0.31925], -[3502, 0.53573, 0.71046, 0.48364], -[3503, 0.55507, 0.53737, 0.05822], -[3504, 0.56950, 0.68375, 0.48496], -[3505, 0.59355, 0.61317, 0.24726], -[3506, 0.57236, 0.59217, 0.16245], -[3507, 0.64017, 0.57718, 0.27796], -[3508, 0.50000, 0.71854, 0.33750], -[3509, 0.67394, 0.56339, 0.35460], -[3510, 0.55116, 0.68443, 0.35604], -[3511, 0.66279, 0.57191, 0.33643], -[3512, 0.59726, 0.60363, 0.23156], -[3513, 0.67321, 0.50000, 0.20000], -[3514, 0.52592, 0.70951, 0.38475], -[3515, 0.63498, 0.61171, 0.37369], -[3516, 0.55182, 0.69920, 0.48549], -[3517, 0.64412, 0.54802, 0.21993], -[3518, 0.63766, 0.62140, 0.46979], -[3519, 0.58981, 0.66605, 0.45307], -[3520, 0.53771, 0.69810, 0.36868], -[3521, 0.87012, 0.00000, 0.30848], -[3522, 0.59827, 0.62097, 0.27560], -[3523, 0.71651, 0.50000, 0.32500], -[3524, 0.71651, 0.17500, 0.00000], -[3525, 0.72911, 0.51204, 0.47824], -[3526, 0.51861, 0.68106, 0.25207], -[3527, 0.52236, 0.64178, 0.16905], -[3528, 0.67966, 0.56898, 0.40693], -[3529, 0.02165, 0.73750, 0.00000], -[3530, 0.70286, 0.53160, 0.36652], -[3531, 0.00000, 0.83750, 0.19486], -[3532, 0.83750, 0.00000, 0.19486], -[3533, 0.51907, 0.71253, 0.36769], -[3534, 0.58240, 0.66926, 0.41305], -[3535, 0.70090, 0.51798, 0.31187], -[3536, 0.65950, 0.52009, 0.20065], -[3537, 0.69051, 0.53553, 0.32243], -[3538, 0.60775, 0.64168, 0.38156], -[3539, 0.47835, 0.56250, 0.00000], -[3540, 0.69201, 0.54205, 0.34988], -[3541, 0.73782, 0.02986, 0.00000], -[3542, 0.59151, 0.65574, 0.37560], -[3543, 0.00000, 0.88750, 0.41136], -[3544, 0.73797, 0.50000, 0.46964], -[3545, 0.60560, 0.52227, 0.10497], -[3546, 0.62115, 0.61190, 0.31187], -[3547, 0.66581, 0.54289, 0.25984], -[3548, 0.71695, 0.52452, 0.41713], -[3549, 0.64738, 0.51699, 0.16881], -[3550, 0.71051, 0.51855, 0.35030], -[3551, 0.54144, 0.57933, 0.09073], -[3552, 0.54977, 0.51785, 0.02471], -[3553, 0.55565, 0.68826, 0.38204], -[3554, 0.65499, 0.54764, 0.24015], -[3555, 0.63463, 0.60566, 0.33577], -[3556, 0.57133, 0.64831, 0.27674], -[3557, 0.58660, 0.50000, 0.05000], -[3558, 0.58660, 0.45000, 0.00000], -[3559, 0.63016, 0.56834, 0.22305], -[3560, 0.66248, 0.59125, 0.40724], -[3561, 0.50000, 0.56699, 0.02500], -[3562, 0.50000, 0.73937, 0.47685], -[3563, 0.56591, 0.52039, 0.04575], -[3564, 0.61895, 0.63443, 0.39134], -[3565, 0.60073, 0.56011, 0.14949], -[3566, 0.51875, 0.71132, 0.35000], -[3567, 0.24019, 0.70000, 0.00000], -[3568, 0.53326, 0.60531, 0.11651], -[3569, 0.53637, 0.63210, 0.16728], -[3570, 0.68107, 0.52627, 0.26067], -[3571, 0.06495, 0.73750, 0.00000], -[3572, 0.50000, 0.69689, 0.25000], -[3573, 0.62324, 0.62839, 0.37760], -[3574, 0.58518, 0.54003, 0.09456], -[3575, 0.71030, 0.53981, 0.44820], -[3576, 0.52885, 0.71739, 0.43438], -[3577, 0.58288, 0.63650, 0.26808], -[3578, 0.51875, 0.72612, 0.45069], -[3579, 0.73816, 0.50000, 0.43750], -[3580, 0.73816, 0.06250, 0.00000], -[3581, 0.53169, 0.66189, 0.22042], -[3582, 0.54223, 0.55663, 0.05828], -[3583, 0.58577, 0.65553, 0.33824], -[3584, 0.51002, 0.60643, 0.08612], -[3585, 0.15359, 0.72500, 0.00000], -[3586, 0.57623, 0.56444, 0.11449], -[3587, 0.88750, 0.00000, 0.39175], -[3588, 0.54188, 0.51434, 0.00883], -[3589, 0.50000, 0.63194, 0.11250], -[3590, 0.67496, 0.57308, 0.37539], -[3591, 0.54963, 0.52976, 0.03433], -[3592, 0.65155, 0.61250, 0.50000], -[3593, 0.50000, 0.65359, 0.15000], -[3594, 0.51634, 0.69549, 0.27778], -[3595, 0.58660, 0.67500, 0.50000], -[3596, 0.63535, 0.59421, 0.29259], -[3597, 0.67663, 0.54920, 0.29862], -[3598, 0.55786, 0.60541, 0.15024], -[3599, 0.60491, 0.64486, 0.36467], -[3600, 0.67473, 0.58616, 0.46241], -[3601, 0.50000, 0.74019, 0.45000], -[3602, 0.51873, 0.72479, 0.42199], -[3603, 0.51895, 0.65751, 0.18542], -[3604, 0.57958, 0.52997, 0.07113], -[3605, 0.61716, 0.56827, 0.18843], -[3606, 0.66044, 0.60405, 0.48814], -[3607, 0.59607, 0.52390, 0.08592], -[3608, 0.67865, 0.52016, 0.23519], -[3609, 0.70716, 0.54024, 0.40272], -[3610, 0.50000, 0.71854, 0.31250], -[3611, 0.62001, 0.52019, 0.11727], -[3612, 0.55661, 0.69667, 0.42003], -[3613, 0.53800, 0.67376, 0.25858], -[3614, 0.69486, 0.50000, 0.23750], -[3615, 0.69486, 0.26250, 0.00000], -[3616, 0.55814, 0.56136, 0.08155], -[3617, 0.60107, 0.58705, 0.19043], -[3618, 0.70504, 0.55129, 0.46738], -[3619, 0.61906, 0.55057, 0.15952], -[3620, 0.50000, 0.55000, 0.00000], -[3621, 0.55000, 0.50000, 0.00000], -[3622, 0.60657, 0.59295, 0.21192], -[3623, 0.73816, 0.50000, 0.41250], -[3624, 0.73816, 0.08750, 0.00000], -[3625, 0.58529, 0.64479, 0.28936], -[3626, 0.00000, 0.85000, 0.21651], -[3627, 0.85000, 0.00000, 0.21651], -[3628, 0.67944, 0.30221, 0.00000], -[3629, 0.61791, 0.61174, 0.28314], -[3630, 0.50000, 0.61029, 0.07500], -[3631, 0.72082, 0.52365, 0.40231], -[3632, 0.71651, 0.50000, 0.30000], -[3633, 0.71651, 0.20000, 0.00000], -[3634, 0.59544, 0.54436, 0.10939], -[3635, 0.52986, 0.59875, 0.09477], -[3636, 0.50000, 0.74019, 0.42500], -[3637, 0.50000, 0.67524, 0.18750], -[3638, 0.56396, 0.67902, 0.34322], -[3639, 0.57025, 0.66948, 0.32531], -[3640, 0.63169, 0.55431, 0.18747], -[3641, 0.56666, 0.59413, 0.13927], -[3642, 0.53535, 0.69395, 0.30996], -[3643, 0.56900, 0.64849, 0.25506], -[3644, 0.55949, 0.62684, 0.18639], -[3645, 0.00000, 0.87500, 0.30311], -[3646, 0.63439, 0.63202, 0.44737], -[3647, 0.54801, 0.67437, 0.27653], -[3648, 0.00000, 0.88750, 0.36806], -[3649, 0.52768, 0.57427, 0.05622], -[3650, 0.21854, 0.71250, 0.00000], -[3651, 0.66377, 0.53636, 0.22218], -[3652, 0.64769, 0.53913, 0.19105], -[3653, 0.10825, 0.73750, 0.00000], -[3654, 0.68953, 0.57010, 0.42762], -[3655, 0.72059, 0.53440, 0.46800], -[3656, 0.65155, 0.50000, 0.13750], -[3657, 0.65155, 0.36250, 0.00000], -[3658, 0.52798, 0.58827, 0.07442], -[3659, 0.60984, 0.65209, 0.40404], -[3660, 0.73612, 0.51195, 0.45016], -[3661, 0.64539, 0.56846, 0.24153], -[3662, 0.55862, 0.69638, 0.40192], -[3663, 0.62990, 0.50000, 0.10000], -[3664, 0.62990, 0.40000, 0.00000], -[3665, 0.68639, 0.55769, 0.34304], -[3666, 0.72198, 0.52076, 0.37971], -[3667, 0.61438, 0.54606, 0.13749], -[3668, 0.53763, 0.68807, 0.28875], -[3669, 0.55554, 0.70484, 0.45877], -[3670, 0.57134, 0.68646, 0.40260], -[3671, 0.55193, 0.68315, 0.31056], -[3672, 0.62557, 0.62544, 0.34237], -[3673, 0.73816, 0.50000, 0.38750], -[3674, 0.73816, 0.11250, 0.00000], -[3675, 0.54966, 0.66448, 0.24722], -[3676, 0.65908, 0.60660, 0.42665], -[3677, 0.58639, 0.60168, 0.18083], -[3678, 0.51902, 0.67134, 0.20375], -[3679, 0.50000, 0.74019, 0.40000], -[3680, 0.60772, 0.62949, 0.29410], -[3681, 0.59808, 0.55461, 0.12200], -[3682, 0.65566, 0.52581, 0.18092], -[3683, 0.57923, 0.67371, 0.36121], -[3684, 0.67321, 0.50000, 0.17500], -[3685, 0.67321, 0.32500, 0.00000], -[3686, 0.60825, 0.66250, 0.50000], -[3687, 0.65184, 0.61786, 0.45207], -[3688, 0.65519, 0.59823, 0.35223], -[3689, 0.77500, 0.00000, 0.04330], -[3690, 0.00000, 0.77500, 0.04330], -[3691, 0.67901, 0.50956, 0.20231], -[3692, 0.61992, 0.65135, 0.47158], -[3693, 0.52221, 0.53542, 0.00000], -[3694, 0.78750, 0.00000, 0.06495], -[3695, 0.00000, 0.78750, 0.06495], -[3696, 0.69437, 0.52969, 0.28390], -[3697, 0.37010, 0.65000, 0.00000], -[3698, 0.58608, 0.68200, 0.46916], -[3699, 0.64478, 0.62346, 0.42718], -[3700, 0.58406, 0.57603, 0.13010], -[3701, 0.39175, 0.63750, 0.00000], -[3702, 0.90000, 0.00000, 0.50000], -[3703, 0.00000, 0.90000, 0.50000], -[3704, 0.57737, 0.63793, 0.23587], -[3705, 0.76250, 0.00000, 0.02165], -[3706, 0.00000, 0.76250, 0.02165], -[3707, 0.34845, 0.66250, 0.00000], -[3708, 0.53179, 0.56061, 0.03822], -[3709, 0.88750, 0.00000, 0.34845], -[3710, 0.80000, 0.00000, 0.08660], -[3711, 0.00000, 0.80000, 0.08660], -[3712, 0.56635, 0.58592, 0.11642], -[3713, 0.50000, 0.69689, 0.22500], -[3714, 0.60825, 0.50000, 0.06250], -[3715, 0.60825, 0.43750, 0.00000], -[3716, 0.50000, 0.71854, 0.28750], -[3717, 0.57444, 0.68974, 0.42391], -[3718, 0.41340, 0.62500, 0.00000], -[3719, 0.59476, 0.58767, 0.16467], -[3720, 0.56436, 0.66972, 0.28901], -[3721, 0.57378, 0.61354, 0.17437], -[3722, 0.90000, 0.00000, 0.45670], -[3723, 0.52092, 0.61850, 0.10233], -[3724, 0.69405, 0.28353, 0.00000], -[3725, 0.53740, 0.54411, 0.02327], -[3726, 0.56054, 0.51872, 0.02148], -[3727, 0.61190, 0.57137, 0.16610], -[3728, 0.63515, 0.62925, 0.38578], -[3729, 0.32679, 0.67500, 0.00000], -[3730, 0.64981, 0.57758, 0.26213], -[3731, 0.57278, 0.53778, 0.05823], -[3732, 0.00000, 0.86250, 0.23816], -[3733, 0.86250, 0.00000, 0.23816], -[3734, 0.75000, 0.50000, 0.50000], -[3735, 0.75000, 0.00000, 0.00000], -[3736, 0.00000, 0.75000, 0.00000], -[3737, 0.50000, 0.75000, 0.50000], -[3738, 0.58176, 0.68671, 0.44711], -[3739, 0.60447, 0.66831, 0.47061], -[3740, 0.55265, 0.59384, 0.10652], -[3741, 0.59330, 0.61665, 0.21591], -[3742, 0.71577, 0.22507, 0.00000], -[3743, 0.54733, 0.69957, 0.34486], -[3744, 0.60119, 0.66639, 0.41286], -[3745, 0.57236, 0.55155, 0.07417], -[3746, 0.67321, 0.60000, 0.50000], -[3747, 0.70330, 0.54724, 0.36124], -[3748, 0.50000, 0.74019, 0.37500], -[3749, 0.81250, 0.00000, 0.10825], -[3750, 0.00000, 0.81250, 0.10825], -[3751, 0.68158, 0.56287, 0.32011], -[3752, 0.73816, 0.50000, 0.36250], -[3753, 0.73816, 0.13750, 0.00000], -[3754, 0.61314, 0.64269, 0.34215], -[3755, 0.71651, 0.50000, 0.27500], -[3756, 0.54871, 0.70735, 0.38659], -[3757, 0.04330, 0.75000, 0.00000], -[3758, 0.19689, 0.72500, 0.00000], -[3759, 0.43505, 0.61250, 0.00000], -[3760, 0.65056, 0.59585, 0.30972], -[3761, 0.00000, 0.90000, 0.43301], -[3762, 0.60370, 0.64774, 0.32509], -[3763, 0.51555, 0.63854, 0.12416], -[3764, 0.68201, 0.58832, 0.43939], -[3765, 0.52376, 0.73478, 0.47296], -[3766, 0.58134, 0.61921, 0.19404], -[3767, 0.62940, 0.53067, 0.12947], -[3768, 0.64699, 0.55780, 0.20787], -[3769, 0.58993, 0.67424, 0.38797], -[3770, 0.57067, 0.69896, 0.46779], -[3771, 0.59884, 0.64643, 0.30268], -[3772, 0.61712, 0.60683, 0.24239], -[3773, 0.69486, 0.50000, 0.21250], -[3774, 0.61235, 0.51089, 0.07629], -[3775, 0.30514, 0.68750, 0.00000], -[3776, 0.52259, 0.68277, 0.22335], -[3777, 0.54800, 0.62607, 0.14842], -[3778, 0.52165, 0.73750, 0.50000], -[3779, 0.53092, 0.72603, 0.41320], -[3780, 0.50000, 0.58831, 0.03036], -[3781, 0.52378, 0.70758, 0.29582], -[3782, 0.63806, 0.63285, 0.40437], -[3783, 0.62070, 0.65406, 0.43887], -[3784, 0.63151, 0.57313, 0.20063], -[3785, 0.62429, 0.64101, 0.37232], -[3786, 0.54460, 0.67159, 0.23674], -[3787, 0.71205, 0.52986, 0.32806], -[3788, 0.52704, 0.72552, 0.38487], -[3789, 0.53426, 0.69036, 0.26453], -[3790, 0.90000, 0.00000, 0.41340], -[3791, 0.82500, 0.00000, 0.12990], -[3792, 0.00000, 0.82500, 0.12990], -[3793, 0.54689, 0.57661, 0.06859], -[3794, 0.67100, 0.60430, 0.45157], -[3795, 0.51659, 0.59436, 0.05543], -[3796, 0.50000, 0.65359, 0.12500], -[3797, 0.66966, 0.56602, 0.27849], -[3798, 0.62646, 0.63628, 0.35633], -[3799, 0.57005, 0.63666, 0.20377], -[3800, 0.55593, 0.64377, 0.19234], -[3801, 0.59726, 0.67617, 0.43385], -[3802, 0.56580, 0.58107, 0.09928], -[3803, 0.00000, 0.88750, 0.32476], -[3804, 0.88750, 0.00000, 0.32476], -[3805, 0.66721, 0.58009, 0.30841], -[3806, 0.45670, 0.60000, 0.00000], -[3807, 0.67362, 0.58431, 0.34664], -[3808, 0.61192, 0.66442, 0.44706], -[3809, 0.51655, 0.73970, 0.43074], -[3810, 0.69635, 0.57559, 0.44817], -[3811, 0.51596, 0.69676, 0.24052], -[3812, 0.71695, 0.54116, 0.38929], -[3813, 0.62990, 0.65000, 0.50000], -[3814, 0.69095, 0.58441, 0.47633], -[3815, 0.50000, 0.63194, 0.08750], -[3816, 0.64022, 0.62307, 0.35346], -[3817, 0.64526, 0.53948, 0.16468], -[3818, 0.50000, 0.67524, 0.16250], -[3819, 0.58894, 0.66259, 0.31565], -[3820, 0.54386, 0.70203, 0.32311], -[3821, 0.08660, 0.75000, 0.00000], -[3822, 0.69420, 0.56469, 0.36100], -[3823, 0.54241, 0.65811, 0.19533], -[3824, 0.28349, 0.70000, 0.00000], -[3825, 0.50000, 0.74019, 0.35000], -[3826, 0.65219, 0.62095, 0.40174], -[3827, 0.67434, 0.51574, 0.18392], -[3828, 0.70914, 0.52362, 0.29120], -[3829, 0.66576, 0.60225, 0.37816], -[3830, 0.54330, 0.52500, 0.00000], -[3831, 0.72500, 0.54330, 0.50000], -[3832, 0.54330, 0.72500, 0.50000], -[3833, 0.58704, 0.47586, 0.00000], -[3834, 0.56852, 0.66525, 0.26468], -[3835, 0.73816, 0.50000, 0.33750], -[3836, 0.73816, 0.16250, 0.00000], -[3837, 0.67763, 0.52651, 0.20856], -[3838, 0.58655, 0.50000, 0.02315], -[3839, 0.67800, 0.60127, 0.47606], -[3840, 0.70865, 0.56140, 0.43187], -[3841, 0.00000, 0.90000, 0.38971], -[3842, 0.66037, 0.62088, 0.47318], -[3843, 0.62792, 0.51859, 0.10110], -[3844, 0.69715, 0.56828, 0.38386], -[3845, 0.72480, 0.54079, 0.43115], -[3846, 0.55285, 0.55145, 0.03859], -[3847, 0.50000, 0.71854, 0.26250], -[3848, 0.64793, 0.52672, 0.14578], -[3849, 0.00000, 0.83750, 0.15155], -[3850, 0.83750, 0.00000, 0.15155], -[3851, 0.61252, 0.54301, 0.10898], -[3852, 0.69984, 0.51439, 0.23800], -[3853, 0.51485, 0.65487, 0.14069], -[3854, 0.66552, 0.56440, 0.25181], -[3855, 0.62790, 0.59001, 0.21578], -[3856, 0.54943, 0.71807, 0.42422], -[3857, 0.59625, 0.53899, 0.07903], -[3858, 0.00000, 0.87500, 0.25981], -[3859, 0.87500, 0.00000, 0.25981], -[3860, 0.64205, 0.59903, 0.27116], -[3861, 0.73837, 0.52293, 0.43030], -[3862, 0.52973, 0.64996, 0.15277], -[3863, 0.54815, 0.71656, 0.40134], -[3864, 0.60630, 0.65911, 0.35185], -[3865, 0.47835, 0.58750, 0.00000], -[3866, 0.66519, 0.59312, 0.32721], -[3867, 0.52431, 0.56174, 0.01654], -[3868, 0.58566, 0.59332, 0.14052], -[3869, 0.51394, 0.72878, 0.32935], -[3870, 0.17524, 0.73750, 0.00000], -[3871, 0.65155, 0.50000, 0.11250], -[3872, 0.65155, 0.38750, 0.00000], -[3873, 0.63713, 0.64304, 0.42742], -[3874, 0.68590, 0.58927, 0.41563], -[3875, 0.54754, 0.72263, 0.44665], -[3876, 0.73260, 0.53433, 0.44843], -[3877, 0.50000, 0.61029, 0.05000], -[3878, 0.52845, 0.72272, 0.34671], -[3879, 0.56797, 0.69531, 0.36202], -[3880, 0.55511, 0.61090, 0.12083], -[3881, 0.58846, 0.52152, 0.04495], -[3882, 0.51736, 0.74065, 0.40416], -[3883, 0.58816, 0.66103, 0.29327], -[3884, 0.50000, 0.69689, 0.20000], -[3885, 0.65400, 0.62010, 0.38394], -[3886, 0.67321, 0.50000, 0.15000], -[3887, 0.67321, 0.35000, 0.00000], -[3888, 0.71651, 0.50000, 0.25000], -[3889, 0.71651, 0.25000, 0.00000], -[3890, 0.65707, 0.59036, 0.28622], -[3891, 0.26184, 0.71250, 0.00000], -[3892, 0.51266, 0.74993, 0.46789], -[3893, 0.55582, 0.69025, 0.29721], -[3894, 0.71250, 0.56495, 0.50000], -[3895, 0.56495, 0.71250, 0.50000], -[3896, 0.90000, 0.00000, 0.37010], -[3897, 0.53764, 0.73314, 0.47961], -[3898, 0.53519, 0.63640, 0.13182], -[3899, 0.64044, 0.63274, 0.37010], -[3900, 0.62990, 0.50000, 0.07500], -[3901, 0.62990, 0.42500, 0.00000], -[3902, 0.53534, 0.62816, 0.11737], -[3903, 0.68568, 0.50890, 0.18591], -[3904, 0.60523, 0.57882, 0.14423], -[3905, 0.62043, 0.63819, 0.31028], -[3906, 0.55802, 0.71870, 0.48064], -[3907, 0.59528, 0.55502, 0.09261], -[3908, 0.64953, 0.63738, 0.48491], -[3909, 0.68982, 0.54741, 0.27002], -[3910, 0.54123, 0.65404, 0.17171], -[3911, 0.72804, 0.52226, 0.33970], -[3912, 0.50000, 0.74019, 0.32500], -[3913, 0.56233, 0.66226, 0.22851], -[3914, 0.70766, 0.53952, 0.30769], -[3915, 0.76052, 0.02306, 0.00000], -[3916, 0.64058, 0.59124, 0.23728], -[3917, 0.76063, 0.50000, 0.47685], -[3918, 0.74547, 0.52206, 0.46854], -[3919, 0.52649, 0.66283, 0.16424], -[3920, 0.00000, 0.85000, 0.17321], -[3921, 0.85000, 0.00000, 0.17321], -[3922, 0.53180, 0.71588, 0.31561], -[3923, 0.12990, 0.75000, 0.00000], -[3924, 0.63615, 0.54640, 0.14477], -[3925, 0.65405, 0.60957, 0.32593], -[3926, 0.61528, 0.63226, 0.27314], -[3927, 0.53833, 0.68814, 0.24220], -[3928, 0.75981, 0.50000, 0.45000], -[3929, 0.75981, 0.05000, 0.00000], -[3930, 0.73816, 0.50000, 0.31250], -[3931, 0.73816, 0.18750, 0.00000], -[3932, 0.51514, 0.68247, 0.18526], -[3933, 0.68477, 0.53566, 0.22717], -[3934, 0.61797, 0.59616, 0.19507], -[3935, 0.54008, 0.72168, 0.36636], -[3936, 0.69486, 0.50000, 0.18750], -[3937, 0.50000, 0.57500, 0.00000], -[3938, 0.57500, 0.50000, 0.00000], -[3939, 0.72383, 0.55346, 0.48040], -[3940, 0.66394, 0.55932, 0.22252], -[3941, 0.60277, 0.61112, 0.19356], -[3942, 0.52162, 0.73514, 0.36477], -[3943, 0.75375, 0.51239, 0.48578], -[3944, 0.65155, 0.63750, 0.50000], -[3945, 0.56953, 0.70941, 0.44242], -[3946, 0.51115, 0.73077, 0.31106], -[3947, 0.58318, 0.67970, 0.32985], -[3948, 0.63078, 0.56799, 0.16723], -[3949, 0.55828, 0.65950, 0.20866], -[3950, 0.50000, 0.76203, 0.46964], -[3951, 0.59993, 0.53147, 0.06493], -[3952, 0.71182, 0.56772, 0.44812], -[3953, 0.02165, 0.76250, 0.00000], -[3954, 0.68198, 0.57150, 0.29920], -[3955, 0.59930, 0.64589, 0.26385], -[3956, 0.57427, 0.61726, 0.15171], -[3957, 0.66803, 0.61799, 0.43579], -[3958, 0.52797, 0.74241, 0.45048], -[3959, 0.72322, 0.52272, 0.30932], -[3960, 0.65083, 0.63854, 0.46201], -[3961, 0.61715, 0.66087, 0.37646], -[3962, 0.75981, 0.50000, 0.42500], -[3963, 0.75981, 0.07500, 0.00000], -[3964, 0.72242, 0.53982, 0.35985], -[3965, 0.66645, 0.52458, 0.16284], -[3966, 0.60581, 0.67393, 0.39102], -[3967, 0.58651, 0.69916, 0.48441], -[3968, 0.91250, 0.00000, 0.47835], -[3969, 0.00000, 0.91250, 0.47835], -[3970, 0.52413, 0.61012, 0.06844], -[3971, 0.69751, 0.55582, 0.30550], -[3972, 0.24019, 0.72500, 0.00000], -[3973, 0.73904, 0.53582, 0.48611], -[3974, 0.58229, 0.59389, 0.12353], -[3975, 0.00000, 0.90000, 0.34641], -[3976, 0.51875, 0.57677, 0.01845], -[3977, 0.56568, 0.61422, 0.13063], -[3978, 0.60674, 0.62808, 0.23306], -[3979, 0.58660, 0.70000, 0.50000], -[3980, 0.60688, 0.50000, 0.03542], -[3981, 0.60688, 0.46458, 0.00000], -[3982, 0.67833, 0.60202, 0.39209], -[3983, 0.50000, 0.76184, 0.43750], -[3984, 0.71443, 0.55405, 0.36977], -[3985, 0.59346, 0.67816, 0.35032], -[3986, 0.70870, 0.57012, 0.41451], -[3987, 0.00000, 0.91250, 0.45466], -[3988, 0.60344, 0.68449, 0.45434], -[3989, 0.57747, 0.57308, 0.08422], -[3990, 0.58723, 0.68776, 0.36996], -[3991, 0.61547, 0.67500, 0.48125], -[3992, 0.59064, 0.60714, 0.15716], -[3993, 0.50000, 0.71854, 0.23750], -[3994, 0.57255, 0.63696, 0.18083], -[3995, 0.63364, 0.64904, 0.38747], -[3996, 0.72557, 0.55422, 0.45751], -[3997, 0.00000, 0.88750, 0.28146], -[3998, 0.88750, 0.00000, 0.28146], -[3999, 0.53468, 0.70693, 0.27682], -[4000, 0.56363, 0.56835, 0.05864], -[4001, 0.68443, 0.50922, 0.17162], -[4002, 0.06495, 0.76250, 0.00000], -[4003, 0.63651, 0.60990, 0.25802], -[4004, 0.56506, 0.69670, 0.32361], -[4005, 0.57672, 0.68304, 0.30806], -[4006, 0.15359, 0.75000, 0.00000], -[4007, 0.70885, 0.52961, 0.26944], -[4008, 0.67781, 0.60864, 0.42087], -[4009, 0.60504, 0.67309, 0.36958], -[4010, 0.54361, 0.61655, 0.09937], -[4011, 0.58163, 0.69704, 0.39026], -[4012, 0.69150, 0.55787, 0.28344], -[4013, 0.61990, 0.67160, 0.46661], -[4014, 0.63415, 0.62132, 0.28027], -[4015, 0.52948, 0.58325, 0.03516], -[4016, 0.75000, 0.52369, 0.50000], -[4017, 0.65918, 0.62002, 0.36633], -[4018, 0.91250, 0.00000, 0.43505], -[4019, 0.52967, 0.61722, 0.08113], -[4020, 0.00000, 0.86250, 0.19486], -[4021, 0.86250, 0.00000, 0.19486], -[4022, 0.50000, 0.65359, 0.10000], -[4023, 0.75981, 0.50000, 0.40000], -[4024, 0.75981, 0.10000, 0.00000], -[4025, 0.67258, 0.54560, 0.20458], -[4026, 0.54810, 0.57494, 0.04572], -[4027, 0.50000, 0.67524, 0.13750], -[4028, 0.64948, 0.55948, 0.17974], -[4029, 0.65094, 0.51639, 0.11628], -[4030, 0.56551, 0.63563, 0.16235], -[4031, 0.50000, 0.74019, 0.30000], -[4032, 0.59714, 0.64293, 0.23911], -[4033, 0.50000, 0.76184, 0.41250], -[4034, 0.62796, 0.60864, 0.22920], -[4035, 0.59072, 0.69374, 0.41085], -[4036, 0.53985, 0.67975, 0.20851], -[4037, 0.61771, 0.58687, 0.16456], -[4038, 0.52165, 0.56250, 0.00000], -[4039, 0.68995, 0.58583, 0.36068], -[4040, 0.68873, 0.58154, 0.33815], -[4041, 0.71651, 0.50000, 0.22500], -[4042, 0.71651, 0.27500, 0.00000], -[4043, 0.53941, 0.73753, 0.43118], -[4044, 0.71571, 0.57157, 0.46887], -[4045, 0.73816, 0.50000, 0.28750], -[4046, 0.73816, 0.21250, 0.00000], -[4047, 0.70346, 0.56370, 0.33434], -[4048, 0.73731, 0.54392, 0.47429], -[4049, 0.57876, 0.65894, 0.23358], -[4050, 0.00000, 0.91250, 0.41136], -[4051, 0.51163, 0.75895, 0.44756], -[4052, 0.69310, 0.59898, 0.46075], -[4053, 0.64558, 0.62896, 0.33164], -[4054, 0.50000, 0.63194, 0.06250], -[4055, 0.51900, 0.74701, 0.38423], -[4056, 0.70519, 0.54554, 0.28567], -[4057, 0.56119, 0.71279, 0.36599], -[4058, 0.70906, 0.56294, 0.35375], -[4059, 0.51728, 0.69805, 0.20621], -[4060, 0.50000, 0.69689, 0.17500], -[4061, 0.65074, 0.61750, 0.30864], -[4062, 0.56621, 0.58336, 0.07501], -[4063, 0.60381, 0.66976, 0.33162], -[4064, 0.53955, 0.59392, 0.05540], -[4065, 0.21854, 0.73750, 0.00000], -[4066, 0.62362, 0.65732, 0.35530], -[4067, 0.57498, 0.54542, 0.03750], -[4068, 0.61270, 0.53747, 0.07841], -[4069, 0.55086, 0.59834, 0.07489], -[4070, 0.64197, 0.65370, 0.44722], -[4071, 0.74244, 0.52844, 0.39144], -[4072, 0.60909, 0.56215, 0.10591], -[4073, 0.39175, 0.66250, 0.00000], -[4074, 0.63354, 0.64373, 0.33679], -[4075, 0.56010, 0.64917, 0.17246], -[4076, 0.37010, 0.67500, 0.00000], -[4077, 0.60825, 0.68750, 0.50000], -[4078, 0.75981, 0.50000, 0.37500], -[4079, 0.75981, 0.12500, 0.00000], -[4080, 0.50000, 0.76184, 0.38750], -[4081, 0.70484, 0.53126, 0.24693], -[4082, 0.10825, 0.76250, 0.00000], -[4083, 0.72135, 0.51533, 0.26037], -[4084, 0.71746, 0.55162, 0.34403], -[4085, 0.41340, 0.65000, 0.00000], -[4086, 0.60692, 0.60593, 0.17145], -[4087, 0.55315, 0.73219, 0.46270], -[4088, 0.57865, 0.69567, 0.34281], -[4089, 0.73134, 0.54755, 0.40601], -[4090, 0.66617, 0.62604, 0.41112], -[4091, 0.67321, 0.62500, 0.50000], -[4092, 0.67321, 0.50000, 0.12500], -[4093, 0.67321, 0.37500, 0.00000], -[4094, 0.58494, 0.67092, 0.27288], -[4095, 0.34845, 0.68750, 0.00000], -[4096, 0.91250, 0.00000, 0.39175], -[4097, 0.62734, 0.56721, 0.14066], -[4098, 0.65155, 0.50000, 0.08750], -[4099, 0.65155, 0.41250, 0.00000], -[4100, 0.55940, 0.54647, 0.01715], -[4101, 0.56326, 0.68387, 0.25552], -[4102, 0.60618, 0.69048, 0.47634], -[4103, 0.59451, 0.55415, 0.07054], -[4104, 0.66086, 0.58531, 0.24355], -[4105, 0.57052, 0.71224, 0.38811], -[4106, 0.61160, 0.67994, 0.40538], -[4107, 0.65652, 0.63826, 0.41629], -[4108, 0.43505, 0.63750, 0.00000], -[4109, 0.63113, 0.55271, 0.12326], -[4110, 0.55313, 0.72562, 0.38477], -[4111, 0.68587, 0.56475, 0.26239], -[4112, 0.62555, 0.66765, 0.40636], -[4113, 0.70934, 0.58080, 0.42607], -[4114, 0.00000, 0.87500, 0.21651], -[4115, 0.87500, 0.00000, 0.21651], -[4116, 0.59301, 0.58416, 0.10853], -[4117, 0.65652, 0.64153, 0.44013], -[4118, 0.68880, 0.55287, 0.24298], -[4119, 0.55793, 0.71066, 0.32684], -[4120, 0.52699, 0.71373, 0.25627], -[4121, 0.60785, 0.66351, 0.30810], -[4122, 0.69486, 0.50000, 0.16250], -[4123, 0.32679, 0.70000, 0.00000], -[4124, 0.70000, 0.32679, 0.00000], -[4125, 0.59267, 0.70300, 0.46262], -[4126, 0.74066, 0.53088, 0.37138], -[4127, 0.63759, 0.53615, 0.10873], -[4128, 0.53582, 0.74148, 0.39885], -[4129, 0.67579, 0.60334, 0.33714], -[4130, 0.55213, 0.70102, 0.27423], -[4131, 0.54655, 0.56507, 0.02120], -[4132, 0.67007, 0.62951, 0.45491], -[4133, 0.51559, 0.65989, 0.11782], -[4134, 0.73109, 0.51778, 0.28842], -[4135, 0.63715, 0.63426, 0.30193], -[4136, 0.61602, 0.63717, 0.25081], -[4137, 0.67206, 0.58307, 0.26345], -[4138, 0.54330, 0.55000, 0.00000], -[4139, 0.58093, 0.55771, 0.05372], -[4140, 0.60051, 0.63806, 0.21708], -[4141, 0.54553, 0.68739, 0.22124], -[4142, 0.75371, 0.52633, 0.44693], -[4143, 0.69636, 0.59117, 0.38330], -[4144, 0.59591, 0.62184, 0.17404], -[4145, 0.72922, 0.55896, 0.43534], -[4146, 0.56780, 0.70785, 0.34200], -[4147, 0.50000, 0.74019, 0.27500], -[4148, 0.80000, 0.00000, 0.04330], -[4149, 0.00000, 0.80000, 0.04330], -[4150, 0.52255, 0.75820, 0.47409], -[4151, 0.00000, 0.90000, 0.30311], -[4152, 0.90000, 0.00000, 0.30311], -[4153, 0.60561, 0.59741, 0.14619], -[4154, 0.65177, 0.64259, 0.39413], -[4155, 0.50000, 0.71854, 0.21250], -[4156, 0.70741, 0.51543, 0.21213], -[4157, 0.78750, 0.00000, 0.02165], -[4158, 0.00000, 0.78750, 0.02165], -[4159, 0.58170, 0.65425, 0.21257], -[4160, 0.70637, 0.58341, 0.40089], -[4161, 0.45670, 0.62500, 0.00000], -[4162, 0.62990, 0.50000, 0.05000], -[4163, 0.62990, 0.45000, 0.00000], -[4164, 0.62887, 0.53280, 0.08776], -[4165, 0.51807, 0.68299, 0.16171], -[4166, 0.50000, 0.76184, 0.36250], -[4167, 0.81250, 0.00000, 0.06495], -[4168, 0.00000, 0.81250, 0.06495], -[4169, 0.72145, 0.56343, 0.39269], -[4170, 0.52085, 0.74417, 0.34370], -[4171, 0.54973, 0.63761, 0.12476], -[4172, 0.56425, 0.53036, 0.00000], -[4173, 0.75981, 0.50000, 0.35000], -[4174, 0.75981, 0.15000, 0.00000], -[4175, 0.55037, 0.65146, 0.14997], -[4176, 0.59359, 0.54330, 0.05009], -[4177, 0.60162, 0.58983, 0.12566], -[4178, 0.00000, 0.91250, 0.36806], -[4179, 0.73764, 0.23706, 0.00000], -[4180, 0.65315, 0.57419, 0.19301], -[4181, 0.50000, 0.61088, 0.02315], -[4182, 0.59849, 0.69886, 0.43713], -[4183, 0.57111, 0.68811, 0.27435], -[4184, 0.55255, 0.72243, 0.34708], -[4185, 0.53731, 0.67763, 0.17948], -[4186, 0.77500, 0.50000, 0.50000], -[4187, 0.77500, 0.00000, 0.00000], -[4188, 0.00000, 0.77500, 0.00000], -[4189, 0.50000, 0.77500, 0.50000], -[4190, 0.75434, 0.51611, 0.37615], -[4191, 0.30514, 0.71250, 0.00000], -[4192, 0.71250, 0.30514, 0.00000], -[4193, 0.68902, 0.61016, 0.43862], -[4194, 0.53088, 0.72613, 0.29530], -[4195, 0.53145, 0.74899, 0.41294], -[4196, 0.64376, 0.56462, 0.15650], -[4197, 0.19689, 0.75000, 0.00000], -[4198, 0.73816, 0.50000, 0.26250], -[4199, 0.57419, 0.65308, 0.19157], -[4200, 0.82500, 0.00000, 0.08660], -[4201, 0.00000, 0.82500, 0.08660], -[4202, 0.65381, 0.58561, 0.21505], -[4203, 0.70445, 0.59315, 0.43885], -[4204, 0.62032, 0.67947, 0.42566], -[4205, 0.75188, 0.52823, 0.41237], -[4206, 0.67843, 0.60987, 0.35899], -[4207, 0.52299, 0.72660, 0.27486], -[4208, 0.60152, 0.51578, 0.02635], -[4209, 0.50967, 0.76819, 0.44990], -[4210, 0.62990, 0.67500, 0.50000], -[4211, 0.04330, 0.77500, 0.00000], -[4212, 0.69731, 0.57536, 0.31160], -[4213, 0.64382, 0.65610, 0.40975], -[4214, 0.58035, 0.59862, 0.10254], -[4215, 0.53056, 0.70396, 0.22400], -[4216, 0.71651, 0.50000, 0.20000], -[4217, 0.65265, 0.61446, 0.27664], -[4218, 0.65008, 0.54045, 0.12751], -[4219, 0.68039, 0.62462, 0.48049], -[4220, 0.52165, 0.76250, 0.50000], -[4221, 0.58534, 0.68375, 0.29165], -[4222, 0.52255, 0.63978, 0.08615], -[4223, 0.63582, 0.67028, 0.48442], -[4224, 0.63770, 0.66488, 0.42887], -[4225, 0.57867, 0.53214, 0.01441], -[4226, 0.61197, 0.62283, 0.19746], -[4227, 0.47835, 0.61250, 0.00000], -[4228, 0.66502, 0.55007, 0.16963], -[4229, 0.55562, 0.66726, 0.18365], -[4230, 0.71250, 0.58864, 0.50000], -[4231, 0.56699, 0.60736, 0.09496], -[4232, 0.55099, 0.73703, 0.41136], -[4233, 0.76720, 0.51253, 0.44162], -[4234, 0.70344, 0.55009, 0.26045], -[4235, 0.83750, 0.00000, 0.10825], -[4236, 0.00000, 0.83750, 0.10825], -[4237, 0.61257, 0.65964, 0.28865], -[4238, 0.75198, 0.51512, 0.34389], -[4239, 0.66785, 0.61237, 0.31511], -[4240, 0.59376, 0.63883, 0.19248], -[4241, 0.64491, 0.57969, 0.17860], -[4242, 0.56723, 0.63536, 0.13946], -[4243, 0.61247, 0.55497, 0.08475], -[4244, 0.62944, 0.61091, 0.20640], -[4245, 0.91250, 0.00000, 0.34845], -[4246, 0.92500, 0.00000, 0.50000], -[4247, 0.00000, 0.92500, 0.50000], -[4248, 0.62347, 0.52310, 0.06033], -[4249, 0.69761, 0.60012, 0.40438], -[4250, 0.62474, 0.66066, 0.32906], -[4251, 0.51551, 0.76229, 0.40430], -[4252, 0.28349, 0.72500, 0.00000], -[4253, 0.52555, 0.62901, 0.07082], -[4254, 0.50000, 0.67524, 0.11250], -[4255, 0.56800, 0.70416, 0.30582], -[4256, 0.00000, 0.88750, 0.23816], -[4257, 0.88750, 0.00000, 0.23816], -[4258, 0.71097, 0.59218, 0.48141], -[4259, 0.57139, 0.61672, 0.11296], -[4260, 0.65685, 0.62873, 0.32698], -[4261, 0.69944, 0.60590, 0.47949], -[4262, 0.64796, 0.52176, 0.09415], -[4263, 0.50000, 0.76184, 0.33750], -[4264, 0.54821, 0.70495, 0.25589], -[4265, 0.63517, 0.64828, 0.31689], -[4266, 0.65892, 0.54678, 0.14773], -[4267, 0.57481, 0.72219, 0.42660], -[4268, 0.62941, 0.67703, 0.44653], -[4269, 0.65865, 0.60386, 0.25717], -[4270, 0.92500, 0.00000, 0.45670], -[4271, 0.72868, 0.55324, 0.35692], -[4272, 0.54330, 0.75000, 0.50000], -[4273, 0.74667, 0.54401, 0.43420], -[4274, 0.50000, 0.65359, 0.07500], -[4275, 0.68766, 0.57965, 0.27863], -[4276, 0.75981, 0.50000, 0.32500], -[4277, 0.75981, 0.17500, 0.00000], -[4278, 0.62749, 0.60151, 0.18002], -[4279, 0.52517, 0.67464, 0.14362], -[4280, 0.69660, 0.53701, 0.20952], -[4281, 0.68561, 0.53437, 0.17997], -[4282, 0.54003, 0.74239, 0.37630], -[4283, 0.08660, 0.77500, 0.00000], -[4284, 0.50000, 0.69689, 0.15000], -[4285, 0.74155, 0.55505, 0.48549], -[4286, 0.59040, 0.66895, 0.25067], -[4287, 0.76495, 0.52109, 0.45987], -[4288, 0.54707, 0.71745, 0.28924], -[4289, 0.73777, 0.54146, 0.35493], -[4290, 0.70870, 0.53244, 0.23012], -[4291, 0.61805, 0.62970, 0.21685], -[4292, 0.74494, 0.52302, 0.32510], -[4293, 0.75649, 0.53498, 0.47432], -[4294, 0.70139, 0.51881, 0.18679], -[4295, 0.67325, 0.57627, 0.22798], -[4296, 0.61465, 0.58053, 0.11979], -[4297, 0.69154, 0.51915, 0.16590], -[4298, 0.85000, 0.00000, 0.12990], -[4299, 0.00000, 0.85000, 0.12990], -[4300, 0.65297, 0.65762, 0.47461], -[4301, 0.56200, 0.58937, 0.05693], -[4302, 0.72433, 0.55131, 0.32410], -[4303, 0.73763, 0.54963, 0.38402], -[4304, 0.71057, 0.57581, 0.34767], -[4305, 0.52837, 0.61065, 0.04433], -[4306, 0.66847, 0.52956, 0.13591], -[4307, 0.52979, 0.75820, 0.43391], -[4308, 0.68045, 0.52107, 0.14588], -[4309, 0.60000, 0.50000, 0.00000], -[4310, 0.50000, 0.60000, 0.00000], -[4311, 0.72576, 0.53919, 0.29360], -[4312, 0.63859, 0.66030, 0.37245], -[4313, 0.00000, 0.92500, 0.43301], -[4314, 0.59902, 0.68312, 0.31357], -[4315, 0.78038, 0.50000, 0.46458], -[4316, 0.78038, 0.03542, 0.00000], -[4317, 0.50000, 0.74019, 0.25000], -[4318, 0.57954, 0.71802, 0.40500], -[4319, 0.63190, 0.64388, 0.28388], -[4320, 0.72163, 0.51903, 0.23416], -[4321, 0.72655, 0.57690, 0.48855], -[4322, 0.59520, 0.60846, 0.13074], -[4323, 0.64712, 0.60231, 0.21826], -[4324, 0.66964, 0.64183, 0.47476], -[4325, 0.61003, 0.52907, 0.04270], -[4326, 0.67832, 0.62255, 0.38226], -[4327, 0.71289, 0.59273, 0.45436], -[4328, 0.54093, 0.74036, 0.35398], -[4329, 0.17524, 0.76250, 0.00000], -[4330, 0.65689, 0.64042, 0.35604], -[4331, 0.55875, 0.74154, 0.48292], -[4332, 0.26184, 0.73750, 0.00000], -[4333, 0.73750, 0.26184, 0.00000], -[4334, 0.64409, 0.59755, 0.19813], -[4335, 0.56495, 0.73750, 0.50000], -[4336, 0.92500, 0.00000, 0.41340], -[4337, 0.67138, 0.55816, 0.18242], -[4338, 0.54415, 0.75239, 0.46891], -[4339, 0.55216, 0.72247, 0.30941], -[4340, 0.59309, 0.71112, 0.42423], -[4341, 0.67321, 0.50000, 0.10000], -[4342, 0.67321, 0.40000, 0.00000], -[4343, 0.66911, 0.57520, 0.20904], -[4344, 0.51227, 0.77500, 0.48406], -[4345, 0.54948, 0.68604, 0.19869], -[4346, 0.00000, 0.91250, 0.32476], -[4347, 0.91250, 0.00000, 0.32476], -[4348, 0.66319, 0.63932, 0.37810], -[4349, 0.65155, 0.66250, 0.50000], -[4350, 0.57664, 0.72716, 0.45283], -[4351, 0.59725, 0.59905, 0.11538], -[4352, 0.53360, 0.64862, 0.10229], -[4353, 0.50000, 0.63078, 0.03542], -[4354, 0.73816, 0.50000, 0.23750], -[4355, 0.50000, 0.71854, 0.18750], -[4356, 0.71573, 0.58055, 0.37844], -[4357, 0.69486, 0.50000, 0.13750], -[4358, 0.69486, 0.36250, 0.00000], -[4359, 0.68624, 0.61983, 0.40441], -[4360, 0.64848, 0.61275, 0.23863], -[4361, 0.56110, 0.73892, 0.44070], -[4362, 0.63528, 0.63595, 0.26263], -[4363, 0.50000, 0.78349, 0.47500], -[4364, 0.62531, 0.58824, 0.14293], -[4365, 0.78146, 0.50000, 0.43750], -[4366, 0.78146, 0.06250, 0.00000], -[4367, 0.56847, 0.56455, 0.02803], -[4368, 0.59839, 0.69733, 0.35745], -[4369, 0.67425, 0.60182, 0.28119], -[4370, 0.54691, 0.61582, 0.06797], -[4371, 0.68245, 0.57761, 0.24383], -[4372, 0.57472, 0.73072, 0.47045], -[4373, 0.00000, 0.86250, 0.15155], -[4374, 0.86250, 0.00000, 0.15155], -[4375, 0.54296, 0.73637, 0.33164], -[4376, 0.50000, 0.76184, 0.31250], -[4377, 0.76952, 0.52247, 0.47823], -[4378, 0.65979, 0.65426, 0.45177], -[4379, 0.58548, 0.70043, 0.32024], -[4380, 0.63363, 0.63013, 0.24085], -[4381, 0.65155, 0.50000, 0.06250], -[4382, 0.65155, 0.43750, 0.00000], -[4383, 0.72404, 0.58044, 0.43028], -[4384, 0.55637, 0.63082, 0.10163], -[4385, 0.71666, 0.55923, 0.30010], -[4386, 0.50000, 0.78349, 0.45000], -[4387, 0.63002, 0.55527, 0.09846], -[4388, 0.55287, 0.66986, 0.16453], -[4389, 0.69903, 0.61510, 0.50000], -[4390, 0.56628, 0.68136, 0.21351], -[4391, 0.62087, 0.65342, 0.26615], -[4392, 0.60373, 0.57605, 0.08667], -[4393, 0.59527, 0.53832, 0.02773], -[4394, 0.52165, 0.58750, 0.00000], -[4395, 0.75981, 0.50000, 0.30000], -[4396, 0.75981, 0.20000, 0.00000], -[4397, 0.58728, 0.52205, 0.00000], -[4398, 0.12990, 0.77500, 0.00000], -[4399, 0.51739, 0.71974, 0.21376], -[4400, 0.00000, 0.90000, 0.25981], -[4401, 0.90000, 0.00000, 0.25981], -[4402, 0.00000, 0.92500, 0.38971], -[4403, 0.75400, 0.54710, 0.48885], -[4404, 0.53245, 0.74024, 0.30869], -[4405, 0.70403, 0.57427, 0.29348], -[4406, 0.77112, 0.51574, 0.41337], -[4407, 0.61459, 0.54425, 0.05932], -[4408, 0.71888, 0.54877, 0.27576], -[4409, 0.66181, 0.62807, 0.31081], -[4410, 0.61680, 0.68077, 0.34378], -[4411, 0.78146, 0.50000, 0.41250], -[4412, 0.78146, 0.08750, 0.00000], -[4413, 0.74060, 0.56505, 0.47250], -[4414, 0.60763, 0.70022, 0.40475], -[4415, 0.70191, 0.60860, 0.42427], -[4416, 0.76753, 0.52460, 0.43211], -[4417, 0.71651, 0.50000, 0.17500], -[4418, 0.60173, 0.69246, 0.33437], -[4419, 0.53073, 0.69571, 0.17847], -[4420, 0.63665, 0.51532, 0.05479], -[4421, 0.51609, 0.76730, 0.38054], -[4422, 0.69589, 0.55842, 0.22929], -[4423, 0.52029, 0.62737, 0.04712], -[4424, 0.56941, 0.73144, 0.39897], -[4425, 0.58318, 0.62893, 0.13420], -[4426, 0.50000, 0.78349, 0.42500], -[4427, 0.72739, 0.57678, 0.41200], -[4428, 0.65798, 0.65734, 0.43264], -[4429, 0.68905, 0.55914, 0.21329], -[4430, 0.58660, 0.72500, 0.50000], -[4431, 0.74388, 0.56035, 0.44816], -[4432, 0.55786, 0.73524, 0.36474], -[4433, 0.70387, 0.61106, 0.46427], -[4434, 0.52202, 0.72634, 0.23526], -[4435, 0.24019, 0.75000, 0.00000], -[4436, 0.54185, 0.63305, 0.08039], -[4437, 0.63224, 0.67683, 0.38708], -[4438, 0.02165, 0.78750, 0.00000], -[4439, 0.66853, 0.51477, 0.10161], -[4440, 0.62543, 0.67931, 0.36507], -[4441, 0.54113, 0.66108, 0.12441], -[4442, 0.52887, 0.60000, 0.01875], -[4443, 0.61669, 0.69114, 0.38404], -[4444, 0.61090, 0.65927, 0.24755], -[4445, 0.67414, 0.52371, 0.12200], -[4446, 0.66411, 0.62169, 0.29005], -[4447, 0.65350, 0.63806, 0.30570], -[4448, 0.58656, 0.63797, 0.15232], -[4449, 0.59448, 0.71047, 0.38190], -[4450, 0.64323, 0.67617, 0.46476], -[4451, 0.60634, 0.67766, 0.28706], -[4452, 0.68632, 0.62818, 0.41847], -[4453, 0.61792, 0.64628, 0.23003], -[4454, 0.62990, 0.50000, 0.02500], -[4455, 0.62990, 0.47500, 0.00000], -[4456, 0.00000, 0.87500, 0.17321], -[4457, 0.87500, 0.00000, 0.17321], -[4458, 0.92500, 0.00000, 0.37010], -[4459, 0.58555, 0.71374, 0.35665], -[4460, 0.51494, 0.64453, 0.06141], -[4461, 0.58358, 0.65095, 0.17035], -[4462, 0.51462, 0.75654, 0.31080], -[4463, 0.67203, 0.62841, 0.33733], -[4464, 0.74426, 0.52942, 0.30299], -[4465, 0.53246, 0.76656, 0.45513], -[4466, 0.66565, 0.59783, 0.23017], -[4467, 0.69317, 0.62558, 0.46158], -[4468, 0.60612, 0.62212, 0.15519], -[4469, 0.78146, 0.50000, 0.38750], -[4470, 0.78146, 0.11250, 0.00000], -[4471, 0.56911, 0.57931, 0.03755], -[4472, 0.50000, 0.74019, 0.22500], -[4473, 0.76516, 0.52611, 0.39376], -[4474, 0.66188, 0.58839, 0.20114], -[4475, 0.63939, 0.65049, 0.29566], -[4476, 0.73162, 0.57962, 0.44914], -[4477, 0.51640, 0.71542, 0.19123], -[4478, 0.50000, 0.78349, 0.40000], -[4479, 0.60416, 0.71310, 0.47975], -[4480, 0.62353, 0.69558, 0.46250], -[4481, 0.69621, 0.61357, 0.38652], -[4482, 0.58377, 0.58503, 0.06281], -[4483, 0.71663, 0.59457, 0.41523], -[4484, 0.06495, 0.78750, 0.00000], -[4485, 0.75907, 0.52762, 0.35905], -[4486, 0.74130, 0.55363, 0.36420], -[4487, 0.62274, 0.51656, 0.03104], -[4488, 0.77500, 0.52369, 0.50000], -[4489, 0.55288, 0.59554, 0.03678], -[4490, 0.70209, 0.59854, 0.34589], -[4491, 0.70922, 0.58534, 0.32851], -[4492, 0.64006, 0.66086, 0.33074], -[4493, 0.74145, 0.52183, 0.26973], -[4494, 0.69319, 0.59399, 0.29555], -[4495, 0.65238, 0.51573, 0.07151], -[4496, 0.50000, 0.76184, 0.28750], -[4497, 0.67321, 0.65000, 0.50000], -[4498, 0.54330, 0.57500, 0.00000], -[4499, 0.68439, 0.53724, 0.15523], -[4500, 0.66009, 0.56997, 0.16042], -[4501, 0.73396, 0.54946, 0.31182], -[4502, 0.57299, 0.60339, 0.07143], -[4503, 0.51594, 0.69076, 0.13563], -[4504, 0.50000, 0.67524, 0.08750], -[4505, 0.39175, 0.68750, 0.00000], -[4506, 0.57744, 0.68603, 0.23156], -[4507, 0.52482, 0.75611, 0.32965], -[4508, 0.65730, 0.64303, 0.32490], -[4509, 0.72480, 0.53965, 0.25563], -[4510, 0.50000, 0.69689, 0.12500], -[4511, 0.61503, 0.58376, 0.10342], -[4512, 0.54427, 0.72499, 0.26637], -[4513, 0.41340, 0.67500, 0.00000], -[4514, 0.66052, 0.53541, 0.10769], -[4515, 0.37010, 0.70000, 0.00000], -[4516, 0.75441, 0.54926, 0.42123], -[4517, 0.63175, 0.69122, 0.48495], -[4518, 0.57166, 0.65467, 0.15108], -[4519, 0.65279, 0.62606, 0.25682], -[4520, 0.60206, 0.65972, 0.21795], -[4521, 0.68480, 0.60909, 0.30617], -[4522, 0.73816, 0.50000, 0.21250], -[4523, 0.61266, 0.64443, 0.20523], -[4524, 0.60825, 0.71250, 0.50000], -[4525, 0.65141, 0.56504, 0.13380], -[4526, 0.55214, 0.75486, 0.44379], -[4527, 0.63007, 0.61745, 0.18440], -[4528, 0.63813, 0.53351, 0.06872], -[4529, 0.75981, 0.50000, 0.27500], -[4530, 0.75981, 0.22500, 0.00000], -[4531, 0.66501, 0.58007, 0.18495], -[4532, 0.74010, 0.51621, 0.24751], -[4533, 0.58999, 0.55966, 0.03438], -[4534, 0.75662, 0.53895, 0.37675], -[4535, 0.43505, 0.66250, 0.00000], -[4536, 0.65232, 0.63517, 0.27800], -[4537, 0.61686, 0.62632, 0.17505], -[4538, 0.57454, 0.72567, 0.35247], -[4539, 0.57496, 0.66617, 0.17696], -[4540, 0.67777, 0.63267, 0.36165], -[4541, 0.76250, 0.54534, 0.50000], -[4542, 0.69606, 0.60100, 0.31807], -[4543, 0.69867, 0.61040, 0.36526], -[4544, 0.75514, 0.54622, 0.39848], -[4545, 0.71354, 0.59291, 0.36498], -[4546, 0.62629, 0.69028, 0.39909], -[4547, 0.34845, 0.71250, 0.00000], -[4548, 0.72543, 0.57091, 0.33601], -[4549, 0.21854, 0.76250, 0.00000], -[4550, 0.71981, 0.57130, 0.31374], -[4551, 0.00000, 0.92500, 0.34641], -[4552, 0.52615, 0.74772, 0.29163], -[4553, 0.93750, 0.00000, 0.47835], -[4554, 0.00000, 0.93750, 0.47835], -[4555, 0.51945, 0.68250, 0.12082], -[4556, 0.60123, 0.56464, 0.05377], -[4557, 0.60970, 0.71094, 0.45249], -[4558, 0.56318, 0.71533, 0.27510], -[4559, 0.75439, 0.53452, 0.34299], -[4560, 0.50000, 0.78349, 0.37500], -[4561, 0.56991, 0.72360, 0.32338], -[4562, 0.78146, 0.50000, 0.36250], -[4563, 0.78146, 0.13750, 0.00000], -[4564, 0.56441, 0.74812, 0.46330], -[4565, 0.50000, 0.65359, 0.05000], -[4566, 0.62529, 0.60984, 0.15824], -[4567, 0.59985, 0.66857, 0.22975], -[4568, 0.63224, 0.57344, 0.11087], -[4569, 0.59252, 0.59514, 0.08181], -[4570, 0.64488, 0.67525, 0.40859], -[4571, 0.50000, 0.71854, 0.16250], -[4572, 0.59498, 0.72290, 0.43968], -[4573, 0.64179, 0.62457, 0.22013], -[4574, 0.71296, 0.53198, 0.20162], -[4575, 0.00000, 0.91250, 0.28146], -[4576, 0.91250, 0.00000, 0.28146], -[4577, 0.61826, 0.70557, 0.47952], -[4578, 0.69386, 0.58513, 0.26172], -[4579, 0.51432, 0.78046, 0.41644], -[4580, 0.55031, 0.75633, 0.42378], -[4581, 0.00000, 0.88750, 0.19486], -[4582, 0.88750, 0.00000, 0.19486], -[4583, 0.64398, 0.58232, 0.14368], -[4584, 0.53416, 0.76032, 0.36822], -[4585, 0.60865, 0.67508, 0.26606], -[4586, 0.00000, 0.93750, 0.45466], -[4587, 0.57135, 0.63876, 0.11712], -[4588, 0.45670, 0.65000, 0.00000], -[4589, 0.53574, 0.71128, 0.20286], -[4590, 0.73031, 0.58906, 0.46944], -[4591, 0.52816, 0.73662, 0.25486], -[4592, 0.72911, 0.57449, 0.35839], -[4593, 0.51647, 0.67452, 0.09992], -[4594, 0.10825, 0.78750, 0.00000], -[4595, 0.62049, 0.68196, 0.32162], -[4596, 0.66378, 0.65767, 0.40443], -[4597, 0.71440, 0.59984, 0.38999], -[4598, 0.32679, 0.72500, 0.00000], -[4599, 0.72500, 0.32679, 0.00000], -[4600, 0.70339, 0.56966, 0.24854], -[4601, 0.62197, 0.70126, 0.43691], -[4602, 0.64979, 0.55552, 0.11019], -[4603, 0.74188, 0.55371, 0.33880], -[4604, 0.69486, 0.50000, 0.11250], -[4605, 0.69486, 0.38750, 0.00000], -[4606, 0.76349, 0.54549, 0.44903], -[4607, 0.93750, 0.00000, 0.43505], -[4608, 0.57193, 0.71870, 0.30104], -[4609, 0.64277, 0.66951, 0.35184], -[4610, 0.59317, 0.68904, 0.26143], -[4611, 0.71647, 0.34693, 0.00000], -[4612, 0.56278, 0.65578, 0.12993], -[4613, 0.52847, 0.69396, 0.14949], -[4614, 0.75494, 0.51640, 0.28279], -[4615, 0.67321, 0.50000, 0.07500], -[4616, 0.67321, 0.42500, 0.00000], -[4617, 0.75000, 0.56699, 0.50000], -[4618, 0.51249, 0.75164, 0.26235], -[4619, 0.63390, 0.66795, 0.30931], -[4620, 0.67743, 0.64829, 0.42657], -[4621, 0.54329, 0.72363, 0.24347], -[4622, 0.65320, 0.66756, 0.38861], -[4623, 0.64852, 0.54438, 0.09034], -[4624, 0.65402, 0.67394, 0.44619], -[4625, 0.73694, 0.57176, 0.37791], -[4626, 0.57981, 0.55607, 0.01056], -[4627, 0.47835, 0.63750, 0.00000], -[4628, 0.77321, 0.53616, 0.49326], -[4629, 0.75908, 0.52228, 0.30920], -[4630, 0.74359, 0.53348, 0.28123], -[4631, 0.54320, 0.68845, 0.15863], -[4632, 0.56495, 0.56250, 0.00000], -[4633, 0.66799, 0.66281, 0.48301], -[4634, 0.72259, 0.59925, 0.43206], -[4635, 0.71651, 0.50000, 0.15000], -[4636, 0.69100, 0.59801, 0.27425], -[4637, 0.68090, 0.64811, 0.45099], -[4638, 0.60833, 0.61145, 0.12291], -[4639, 0.67988, 0.64368, 0.40212], -[4640, 0.50000, 0.78349, 0.35000], -[4641, 0.57693, 0.73406, 0.37746], -[4642, 0.00000, 0.93750, 0.41136], -[4643, 0.68139, 0.60192, 0.25470], -[4644, 0.62990, 0.70000, 0.50000], -[4645, 0.50000, 0.76184, 0.26250], -[4646, 0.58636, 0.57974, 0.04492], -[4647, 0.30514, 0.73750, 0.00000], -[4648, 0.73750, 0.30514, 0.00000], -[4649, 0.62574, 0.57201, 0.08978], -[4650, 0.61875, 0.68081, 0.29819], -[4651, 0.78146, 0.50000, 0.33750], -[4652, 0.78146, 0.16250, 0.00000], -[4653, 0.78698, 0.51653, 0.46445], -[4654, 0.72660, 0.51801, 0.19792], -[4655, 0.53688, 0.76633, 0.39009], -[4656, 0.55535, 0.65274, 0.10842], -[4657, 0.50000, 0.74019, 0.20000], -[4658, 0.71693, 0.55292, 0.23877], -[4659, 0.64123, 0.68697, 0.43037], -[4660, 0.55783, 0.68782, 0.17793], -[4661, 0.76604, 0.52096, 0.32689], -[4662, 0.57235, 0.74415, 0.41731], -[4663, 0.77326, 0.53834, 0.47436], -[4664, 0.65155, 0.50000, 0.03750], -[4665, 0.65155, 0.46250, 0.00000], -[4666, 0.73112, 0.58655, 0.39942], -[4667, 0.59987, 0.72639, 0.46392], -[4668, 0.67696, 0.62951, 0.31477], -[4669, 0.51865, 0.78641, 0.46159], -[4670, 0.81250, 0.00000, 0.02165], -[4671, 0.00000, 0.81250, 0.02165], -[4672, 0.74672, 0.56760, 0.40345], -[4673, 0.60242, 0.71890, 0.40314], -[4674, 0.82500, 0.00000, 0.04330], -[4675, 0.00000, 0.82500, 0.04330], -[4676, 0.71310, 0.57316, 0.27151], -[4677, 0.69486, 0.63750, 0.50000], -[4678, 0.19689, 0.77500, 0.00000], -[4679, 0.68444, 0.57259, 0.19462], -[4680, 0.75981, 0.50000, 0.25000], -[4681, 0.63219, 0.63308, 0.20108], -[4682, 0.65369, 0.67977, 0.47707], -[4683, 0.69053, 0.61727, 0.32079], -[4684, 0.57692, 0.70645, 0.25898], -[4685, 0.80000, 0.50000, 0.50000], -[4686, 0.80000, 0.00000, 0.00000], -[4687, 0.00000, 0.80000, 0.00000], -[4688, 0.50000, 0.80000, 0.50000], -[4689, 0.74189, 0.51368, 0.22475], -[4690, 0.63274, 0.65223, 0.24646], -[4691, 0.55890, 0.70295, 0.21093], -[4692, 0.65107, 0.65719, 0.31481], -[4693, 0.53935, 0.77375, 0.47582], -[4694, 0.70886, 0.61542, 0.40451], -[4695, 0.78151, 0.52596, 0.44565], -[4696, 0.00000, 0.90000, 0.21651], -[4697, 0.90000, 0.00000, 0.21651], -[4698, 0.73750, 0.58864, 0.50000], -[4699, 0.52476, 0.78194, 0.43992], -[4700, 0.56249, 0.75150, 0.40273], -[4701, 0.58420, 0.70798, 0.28071], -[4702, 0.93750, 0.00000, 0.39175], -[4703, 0.50000, 0.62500, 0.00000], -[4704, 0.62500, 0.50000, 0.00000], -[4705, 0.60438, 0.64279, 0.16504], -[4706, 0.83750, 0.00000, 0.06495], -[4707, 0.00000, 0.83750, 0.06495], -[4708, 0.67259, 0.61956, 0.26646], -[4709, 0.61373, 0.64273, 0.18206], -[4710, 0.71429, 0.51727, 0.16336], -[4711, 0.63396, 0.55596, 0.07557], -[4712, 0.56420, 0.58088, 0.01475], -[4713, 0.61117, 0.55148, 0.03779], -[4714, 0.51469, 0.74761, 0.23985], -[4715, 0.58441, 0.67491, 0.19217], -[4716, 0.04330, 0.80000, 0.00000], -[4717, 0.72112, 0.60928, 0.47244], -[4718, 0.68693, 0.59242, 0.23689], -[4719, 0.61489, 0.70435, 0.36609], -[4720, 0.70185, 0.53742, 0.16713], -[4721, 0.59166, 0.73182, 0.41879], -[4722, 0.52165, 0.78750, 0.50000], -[4723, 0.62624, 0.67173, 0.27873], -[4724, 0.59637, 0.61618, 0.10361], -[4725, 0.73816, 0.50000, 0.18750], -[4726, 0.72955, 0.52951, 0.21720], -[4727, 0.55797, 0.67495, 0.14520], -[4728, 0.28349, 0.75000, 0.00000], -[4729, 0.75000, 0.28349, 0.00000], -[4730, 0.59578, 0.71463, 0.33505], -[4731, 0.77498, 0.52567, 0.37300], -[4732, 0.15155, 0.78750, 0.00000], -[4733, 0.54691, 0.74241, 0.29300], -[4734, 0.68591, 0.55574, 0.16230], -[4735, 0.85000, 0.00000, 0.08660], -[4736, 0.00000, 0.85000, 0.08660], -[4737, 0.68988, 0.64591, 0.47926], -[4738, 0.70431, 0.63033, 0.48222], -[4739, 0.73104, 0.59938, 0.48994], -[4740, 0.66159, 0.64352, 0.29515], -[4741, 0.52174, 0.78114, 0.39310], -[4742, 0.62884, 0.70125, 0.41753], -[4743, 0.56145, 0.71290, 0.23438], -[4744, 0.74402, 0.57985, 0.43472], -[4745, 0.69424, 0.55703, 0.18084], -[4746, 0.53587, 0.77419, 0.41162], -[4747, 0.67129, 0.65258, 0.36629], -[4748, 0.00000, 0.92500, 0.30311], -[4749, 0.92500, 0.00000, 0.30311], -[4750, 0.77235, 0.53861, 0.41164], -[4751, 0.50000, 0.78349, 0.32500], -[4752, 0.59377, 0.70757, 0.29613], -[4753, 0.63002, 0.59444, 0.11985], -[4754, 0.52091, 0.63062, 0.02448], -[4755, 0.56389, 0.63307, 0.07995], -[4756, 0.71064, 0.62188, 0.44077], -[4757, 0.66933, 0.55146, 0.12153], -[4758, 0.52303, 0.77514, 0.35488], -[4759, 0.80311, 0.50000, 0.47500], -[4760, 0.80311, 0.02500, 0.00000], -[4761, 0.66722, 0.67003, 0.46111], -[4762, 0.50000, 0.69689, 0.10000], -[4763, 0.78146, 0.50000, 0.31250], -[4764, 0.78146, 0.18750, 0.00000], -[4765, 0.61107, 0.71858, 0.42107], -[4766, 0.77317, 0.50623, 0.29517], -[4767, 0.61445, 0.60104, 0.10335], -[4768, 0.56263, 0.75178, 0.37991], -[4769, 0.71889, 0.54846, 0.21947], -[4770, 0.00000, 0.93750, 0.36806], -[4771, 0.67956, 0.62650, 0.29493], -[4772, 0.56128, 0.62269, 0.05979], -[4773, 0.58660, 0.55000, 0.00000], -[4774, 0.63906, 0.60617, 0.15230], -[4775, 0.65958, 0.60402, 0.18871], -[4776, 0.67730, 0.55370, 0.13725], -[4777, 0.60442, 0.66214, 0.19474], -[4778, 0.58313, 0.62998, 0.09971], -[4779, 0.67000, 0.61853, 0.24368], -[4780, 0.65155, 0.68750, 0.50000], -[4781, 0.52165, 0.61250, 0.00000], -[4782, 0.75993, 0.56231, 0.43970], -[4783, 0.53743, 0.65266, 0.07277], -[4784, 0.50000, 0.67524, 0.06250], -[4785, 0.86250, 0.00000, 0.10825], -[4786, 0.00000, 0.86250, 0.10825], -[4787, 0.56299, 0.74641, 0.34722], -[4788, 0.80311, 0.50000, 0.45000], -[4789, 0.80311, 0.05000, 0.00000], -[4790, 0.08660, 0.80000, 0.00000], -[4791, 0.53842, 0.72718, 0.21921], -[4792, 0.54416, 0.75916, 0.34155], -[4793, 0.54254, 0.77666, 0.50000], -[4794, 0.58451, 0.64899, 0.13292], -[4795, 0.68171, 0.59285, 0.21454], -[4796, 0.50000, 0.71854, 0.13750], -[4797, 0.69753, 0.57815, 0.22235], -[4798, 0.55972, 0.76438, 0.48079], -[4799, 0.72500, 0.61029, 0.50000], -[4800, 0.50000, 0.80429, 0.46458], -[4801, 0.67289, 0.64425, 0.32502], -[4802, 0.55001, 0.62611, 0.04825], -[4803, 0.51445, 0.76357, 0.27433], -[4804, 0.52722, 0.71159, 0.16164], -[4805, 0.66707, 0.53157, 0.08602], -[4806, 0.58367, 0.74490, 0.44095], -[4807, 0.64343, 0.69473, 0.45112], -[4808, 0.66352, 0.61779, 0.22228], -[4809, 0.57062, 0.69276, 0.19416], -[4810, 0.58634, 0.70080, 0.24672], -[4811, 0.69932, 0.62132, 0.34507], -[4812, 0.57202, 0.68297, 0.17523], -[4813, 0.72411, 0.59216, 0.34461], -[4814, 0.58010, 0.74993, 0.48181], -[4815, 0.50000, 0.76184, 0.23750], -[4816, 0.71474, 0.59281, 0.30750], -[4817, 0.58358, 0.61989, 0.08226], -[4818, 0.68553, 0.64421, 0.37988], -[4819, 0.75497, 0.57287, 0.46204], -[4820, 0.70639, 0.59236, 0.27670], -[4821, 0.61767, 0.57464, 0.06627], -[4822, 0.70456, 0.53120, 0.15161], -[4823, 0.26184, 0.76250, 0.00000], -[4824, 0.76250, 0.26184, 0.00000], -[4825, 0.61700, 0.53777, 0.02032], -[4826, 0.72451, 0.56381, 0.26076], -[4827, 0.60876, 0.68198, 0.24611], -[4828, 0.55502, 0.75654, 0.35939], -[4829, 0.77725, 0.52164, 0.34486], -[4830, 0.54924, 0.65386, 0.08631], -[4831, 0.63958, 0.52358, 0.03395], -[4832, 0.61973, 0.62064, 0.13775], -[4833, 0.64795, 0.68121, 0.37091], -[4834, 0.56495, 0.76250, 0.50000], -[4835, 0.80311, 0.50000, 0.42500], -[4836, 0.80311, 0.07500, 0.00000], -[4837, 0.74817, 0.58344, 0.47857], -[4838, 0.59030, 0.73589, 0.39679], -[4839, 0.59888, 0.67716, 0.21106], -[4840, 0.69623, 0.64202, 0.43816], -[4841, 0.54614, 0.77375, 0.43815], -[4842, 0.51725, 0.64861, 0.03893], -[4843, 0.70467, 0.63090, 0.42055], -[4844, 0.69898, 0.62879, 0.36943], -[4845, 0.52085, 0.74195, 0.21846], -[4846, 0.74363, 0.58206, 0.40297], -[4847, 0.00000, 0.91250, 0.23816], -[4848, 0.91250, 0.00000, 0.23816], -[4849, 0.78954, 0.51856, 0.40469], -[4850, 0.60742, 0.70641, 0.31704], -[4851, 0.63885, 0.64663, 0.22575], -[4852, 0.66788, 0.64804, 0.31087], -[4853, 0.57889, 0.60290, 0.04924], -[4854, 0.54205, 0.66994, 0.10105], -[4855, 0.55318, 0.70650, 0.18899], -[4856, 0.93750, 0.00000, 0.34845], -[4857, 0.66668, 0.58724, 0.16447], -[4858, 0.67776, 0.64659, 0.34342], -[4859, 0.73857, 0.53453, 0.23376], -[4860, 0.65557, 0.63437, 0.23560], -[4861, 0.50000, 0.80514, 0.43750], -[4862, 0.53572, 0.64376, 0.05167], -[4863, 0.61905, 0.71190, 0.38861], -[4864, 0.75586, 0.55472, 0.34690], -[4865, 0.95000, 0.00000, 0.50000], -[4866, 0.00000, 0.95000, 0.50000], -[4867, 0.75715, 0.56143, 0.38139], -[4868, 0.87500, 0.00000, 0.12990], -[4869, 0.00000, 0.87500, 0.12990], -[4870, 0.60472, 0.69848, 0.27845], -[4871, 0.55774, 0.60000, 0.01875], -[4872, 0.66243, 0.57200, 0.13013], -[4873, 0.50000, 0.65359, 0.02500], -[4874, 0.75981, 0.50000, 0.22500], -[4875, 0.62350, 0.65627, 0.21098], -[4876, 0.69486, 0.50000, 0.08750], -[4877, 0.69486, 0.41250, 0.00000], -[4878, 0.63339, 0.55078, 0.05452], -[4879, 0.64267, 0.66026, 0.26752], -[4880, 0.64921, 0.64836, 0.25266], -[4881, 0.56365, 0.72453, 0.25406], -[4882, 0.66105, 0.67836, 0.42231], -[4883, 0.67020, 0.60465, 0.20263], -[4884, 0.78715, 0.52729, 0.42507], -[4885, 0.50000, 0.74019, 0.17500], -[4886, 0.61055, 0.52988, 0.00000], -[4887, 0.52099, 0.76648, 0.28866], -[4888, 0.59949, 0.55817, 0.01762], -[4889, 0.76059, 0.54160, 0.32152], -[4890, 0.62096, 0.70231, 0.34215], -[4891, 0.50000, 0.78349, 0.30000], -[4892, 0.71651, 0.50000, 0.12500], -[4893, 0.71163, 0.54813, 0.18821], -[4894, 0.56941, 0.75957, 0.44610], -[4895, 0.95000, 0.00000, 0.45670], -[4896, 0.64439, 0.61750, 0.17155], -[4897, 0.54911, 0.61744, 0.02893], -[4898, 0.68308, 0.57479, 0.17184], -[4899, 0.74352, 0.55472, 0.28988], -[4900, 0.59072, 0.72186, 0.31385], -[4901, 0.70212, 0.61727, 0.32421], -[4902, 0.60577, 0.71843, 0.35208], -[4903, 0.80311, 0.50000, 0.40000], -[4904, 0.80311, 0.10000, 0.00000], -[4905, 0.73169, 0.56678, 0.28002], -[4906, 0.76055, 0.51885, 0.26043], -[4907, 0.54215, 0.74642, 0.26769], -[4908, 0.54330, 0.60000, 0.00000], -[4909, 0.56510, 0.74571, 0.32728], -[4910, 0.63496, 0.69816, 0.37816], -[4911, 0.73319, 0.60471, 0.45288], -[4912, 0.52610, 0.67203, 0.07922], -[4913, 0.66114, 0.66515, 0.33877], -[4914, 0.62732, 0.67263, 0.25583], -[4915, 0.66012, 0.53718, 0.07422], -[4916, 0.67321, 0.50000, 0.05000], -[4917, 0.67321, 0.45000, 0.00000], -[4918, 0.71842, 0.61193, 0.37688], -[4919, 0.78146, 0.50000, 0.28750], -[4920, 0.50000, 0.80514, 0.41250], -[4921, 0.74021, 0.55154, 0.26781], -[4922, 0.70069, 0.52421, 0.12548], -[4923, 0.55769, 0.77006, 0.45471], -[4924, 0.58008, 0.67361, 0.15959], -[4925, 0.78132, 0.21372, 0.00000], -[4926, 0.71360, 0.62879, 0.46066], -[4927, 0.77083, 0.51333, 0.27979], -[4928, 0.58489, 0.57442, 0.01576], -[4929, 0.58660, 0.75000, 0.50000], -[4930, 0.60633, 0.64108, 0.14222], -[4931, 0.12990, 0.80000, 0.00000], -[4932, 0.00000, 0.95000, 0.43301], -[4933, 0.61747, 0.56601, 0.04677], -[4934, 0.73646, 0.59866, 0.41979], -[4935, 0.65770, 0.62042, 0.20023], -[4936, 0.67556, 0.66246, 0.38962], -[4937, 0.52908, 0.73291, 0.19903], -[4938, 0.71544, 0.62916, 0.50000], -[4939, 0.53678, 0.71996, 0.18174], -[4940, 0.68278, 0.53274, 0.10273], -[4941, 0.76210, 0.57164, 0.48144], -[4942, 0.71176, 0.57175, 0.22706], -[4943, 0.59432, 0.65834, 0.15145], -[4944, 0.63221, 0.54231, 0.03690], -[4945, 0.24019, 0.77500, 0.00000], -[4946, 0.77447, 0.55515, 0.48065], -[4947, 0.54838, 0.70571, 0.16889], -[4948, 0.68507, 0.51731, 0.08588], -[4949, 0.60568, 0.73574, 0.48259], -[4950, 0.65464, 0.52951, 0.05328], -[4951, 0.64802, 0.56646, 0.09038], -[4952, 0.70468, 0.63311, 0.39399], -[4953, 0.73816, 0.50000, 0.16250], -[4954, 0.67321, 0.67500, 0.50000], -[4955, 0.61770, 0.72542, 0.46731], -[4956, 0.62502, 0.66803, 0.23170], -[4957, 0.69082, 0.54229, 0.12891], -[4958, 0.67311, 0.67180, 0.43183], -[4959, 0.55256, 0.68423, 0.13181], -[4960, 0.00000, 0.88750, 0.15155], -[4961, 0.88750, 0.00000, 0.15155], -[4962, 0.74603, 0.58927, 0.42545], -[4963, 0.63921, 0.69218, 0.35272], -[4964, 0.65075, 0.68883, 0.39253], -[4965, 0.60186, 0.73842, 0.45519], -[4966, 0.00000, 0.93750, 0.32476], -[4967, 0.93750, 0.00000, 0.32476], -[4968, 0.74428, 0.56922, 0.32197], -[4969, 0.72299, 0.61716, 0.42200], -[4970, 0.95000, 0.00000, 0.41340], -[4971, 0.74970, 0.53611, 0.25376], -[4972, 0.76841, 0.52650, 0.29360], -[4973, 0.52117, 0.70306, 0.11993], -[4974, 0.80691, 0.50905, 0.48669], -[4975, 0.61687, 0.72598, 0.44593], -[4976, 0.59971, 0.69154, 0.23051], -[4977, 0.64237, 0.70508, 0.47157], -[4978, 0.77859, 0.54749, 0.43188], -[4979, 0.63655, 0.63676, 0.18387], -[4980, 0.80311, 0.50000, 0.37500], -[4981, 0.80311, 0.12500, 0.00000], -[4982, 0.02165, 0.81250, 0.00000], -[4983, 0.60733, 0.72521, 0.37402], -[4984, 0.41340, 0.70000, 0.00000], -[4985, 0.50000, 0.80514, 0.38750], -[4986, 0.66048, 0.60302, 0.16672], -[4987, 0.53870, 0.76239, 0.30080], -[4988, 0.39175, 0.71250, 0.00000], -[4989, 0.53232, 0.78236, 0.37451], -[4990, 0.59118, 0.73375, 0.34653], -[4991, 0.53052, 0.77697, 0.33733], -[4992, 0.56869, 0.73701, 0.28756], -[4993, 0.53680, 0.74390, 0.23486], -[4994, 0.56465, 0.68824, 0.15451], -[4995, 0.43505, 0.68750, 0.00000], -[4996, 0.65350, 0.57584, 0.10850], -[4997, 0.57465, 0.64454, 0.09220], -[4998, 0.64713, 0.68254, 0.33344], -[4999, 0.56208, 0.73812, 0.27251], -[5000, 0.37010, 0.72500, 0.00000], -[5001, 0.72500, 0.37010, 0.00000], -[5002, 0.71854, 0.61240, 0.35392], -[5003, 0.63235, 0.71467, 0.45328], -[5004, 0.73122, 0.58894, 0.32301], -[5005, 0.75056, 0.55906, 0.30754], -[5006, 0.69826, 0.60599, 0.25877], -[5007, 0.62428, 0.63618, 0.15568], -[5008, 0.50000, 0.76184, 0.21250], -[5009, 0.55846, 0.67397, 0.11659], -[5010, 0.66876, 0.67688, 0.41103], -[5011, 0.00000, 0.92500, 0.25981], -[5012, 0.92500, 0.00000, 0.25981], -[5013, 0.69778, 0.64765, 0.41595], -[5014, 0.72655, 0.58132, 0.28169], -[5015, 0.64895, 0.67649, 0.31371], -[5016, 0.78885, 0.51220, 0.33001], -[5017, 0.77498, 0.54811, 0.38707], -[5018, 0.63992, 0.67836, 0.28974], -[5019, 0.60825, 0.73750, 0.50000], -[5020, 0.76093, 0.54255, 0.29858], -[5021, 0.68019, 0.57300, 0.14914], -[5022, 0.65474, 0.66415, 0.28935], -[5023, 0.71560, 0.58575, 0.25711], -[5024, 0.45670, 0.67500, 0.00000], -[5025, 0.80000, 0.52369, 0.50000], -[5026, 0.53996, 0.68767, 0.11295], -[5027, 0.56495, 0.58750, 0.00000], -[5028, 0.79459, 0.53165, 0.48222], -[5029, 0.06495, 0.81250, 0.00000], -[5030, 0.57890, 0.72524, 0.26913], -[5031, 0.61650, 0.70192, 0.29591], -[5032, 0.50000, 0.78349, 0.27500], -[5033, 0.80121, 0.51912, 0.44405], -[5034, 0.00000, 0.95000, 0.38971], -[5035, 0.71014, 0.56804, 0.20375], -[5036, 0.76098, 0.53329, 0.27356], -[5037, 0.68736, 0.66455, 0.47082], -[5038, 0.73266, 0.58176, 0.30059], -[5039, 0.55321, 0.76926, 0.36876], -[5040, 0.52498, 0.66389, 0.05423], -[5041, 0.34845, 0.73750, 0.00000], -[5042, 0.73750, 0.34845, 0.00000], -[5043, 0.67331, 0.52143, 0.06395], -[5044, 0.69734, 0.62497, 0.30377], -[5045, 0.54251, 0.76733, 0.32028], -[5046, 0.60428, 0.66495, 0.17106], -[5047, 0.76875, 0.55315, 0.36339], -[5048, 0.55015, 0.74310, 0.25353], -[5049, 0.68292, 0.66452, 0.41128], -[5050, 0.52073, 0.79955, 0.42575], -[5051, 0.54647, 0.70262, 0.14831], -[5052, 0.62321, 0.59246, 0.07965], -[5053, 0.70800, 0.64316, 0.46543], -[5054, 0.59856, 0.60545, 0.06253], -[5055, 0.65109, 0.51104, 0.01920], -[5056, 0.50000, 0.69689, 0.07500], -[5057, 0.53756, 0.63734, 0.02970], -[5058, 0.68295, 0.61246, 0.22641], -[5059, 0.59086, 0.69293, 0.20478], -[5060, 0.58377, 0.70703, 0.22477], -[5061, 0.51474, 0.69009, 0.08136], -[5062, 0.50000, 0.71854, 0.11250], -[5063, 0.65457, 0.58996, 0.12571], -[5064, 0.55453, 0.64581, 0.06178], -[5065, 0.52082, 0.73598, 0.17783], -[5066, 0.00000, 0.90000, 0.17321], -[5067, 0.90000, 0.00000, 0.17321], -[5068, 0.51955, 0.79844, 0.40285], -[5069, 0.57720, 0.73969, 0.30872], -[5070, 0.78146, 0.50000, 0.26250], -[5071, 0.78146, 0.23750, 0.00000], -[5072, 0.50000, 0.80514, 0.36250], -[5073, 0.58458, 0.75765, 0.46152], -[5074, 0.75578, 0.58555, 0.44371], -[5075, 0.58088, 0.62236, 0.06125], -[5076, 0.68948, 0.62209, 0.26573], -[5077, 0.74448, 0.58170, 0.34293], -[5078, 0.75981, 0.50000, 0.20000], -[5079, 0.80311, 0.50000, 0.35000], -[5080, 0.80311, 0.15000, 0.00000], -[5081, 0.78750, 0.54534, 0.50000], -[5082, 0.59582, 0.71074, 0.26038], -[5083, 0.47835, 0.66250, 0.00000], -[5084, 0.58207, 0.59699, 0.02823], -[5085, 0.21854, 0.78750, 0.00000], -[5086, 0.71947, 0.51850, 0.13739], -[5087, 0.72639, 0.53471, 0.17683], -[5088, 0.62664, 0.71909, 0.40918], -[5089, 0.63920, 0.58591, 0.09237], -[5090, 0.77488, 0.54315, 0.34969], -[5091, 0.73076, 0.61170, 0.40067], -[5092, 0.73899, 0.55424, 0.24530], -[5093, 0.76924, 0.56237, 0.39909], -[5094, 0.68555, 0.59354, 0.18973], -[5095, 0.60934, 0.61256, 0.08503], -[5096, 0.57957, 0.74703, 0.34228], -[5097, 0.58085, 0.67110, 0.13793], -[5098, 0.74451, 0.60098, 0.43928], -[5099, 0.57659, 0.66057, 0.11222], -[5100, 0.73538, 0.59977, 0.36311], -[5101, 0.32679, 0.75000, 0.00000], -[5102, 0.75000, 0.32679, 0.00000], -[5103, 0.75025, 0.51984, 0.20643], -[5104, 0.95000, 0.00000, 0.37010], -[5105, 0.63907, 0.71190, 0.43549], -[5106, 0.65251, 0.69774, 0.41710], -[5107, 0.74286, 0.51767, 0.18428], -[5108, 0.71760, 0.61195, 0.32659], -[5109, 0.52771, 0.80046, 0.48125], -[5110, 0.75873, 0.52392, 0.23652], -[5111, 0.77625, 0.53613, 0.32787], -[5112, 0.70365, 0.61236, 0.27717], -[5113, 0.64955, 0.55107, 0.05931], -[5114, 0.50000, 0.67524, 0.03750], -[5115, 0.51082, 0.81160, 0.48199], -[5116, 0.51276, 0.79307, 0.33238], -[5117, 0.17321, 0.80000, 0.00000], -[5118, 0.63765, 0.69061, 0.30904], -[5119, 0.72642, 0.57189, 0.24429], -[5120, 0.53108, 0.75909, 0.25112], -[5121, 0.57843, 0.75273, 0.36176], -[5122, 0.50000, 0.74019, 0.15000], -[5123, 0.64676, 0.63941, 0.19464], -[5124, 0.67054, 0.63985, 0.25212], -[5125, 0.51670, 0.79715, 0.36506], -[5126, 0.60938, 0.68692, 0.22151], -[5127, 0.66382, 0.51594, 0.03750], -[5128, 0.69435, 0.64707, 0.35866], -[5129, 0.61108, 0.59667, 0.06247], -[5130, 0.75399, 0.58310, 0.38831], -[5131, 0.75303, 0.59387, 0.46147], -[5132, 0.69454, 0.63807, 0.32073], -[5133, 0.69486, 0.66250, 0.50000], -[5134, 0.10825, 0.81250, 0.00000], -[5135, 0.51532, 0.72878, 0.14605], -[5136, 0.77500, 0.56699, 0.50000], -[5137, 0.62016, 0.67667, 0.21745], -[5138, 0.60613, 0.74198, 0.43345], -[5139, 0.62990, 0.72500, 0.50000], -[5140, 0.51911, 0.77088, 0.25773], -[5141, 0.65000, 0.50000, 0.00000], -[5142, 0.50000, 0.65000, 0.00000], -[5143, 0.75539, 0.57829, 0.36590], -[5144, 0.52656, 0.78040, 0.30824], -[5145, 0.56055, 0.76606, 0.35126], -[5146, 0.71651, 0.50000, 0.10000], -[5147, 0.71651, 0.40000, 0.00000], -[5148, 0.66788, 0.66846, 0.32524], -[5149, 0.52912, 0.71556, 0.13738], -[5150, 0.70538, 0.55145, 0.15081], -[5151, 0.58999, 0.72990, 0.29235], -[5152, 0.79098, 0.53482, 0.38853], -[5153, 0.69486, 0.50000, 0.06250], -[5154, 0.69486, 0.43750, 0.00000], -[5155, 0.55133, 0.72736, 0.19781], -[5156, 0.73672, 0.61757, 0.48479], -[5157, 0.53258, 0.68920, 0.09287], -[5158, 0.52547, 0.80346, 0.44782], -[5159, 0.70334, 0.52156, 0.10282], -[5160, 0.30514, 0.76250, 0.00000], -[5161, 0.76250, 0.30514, 0.00000], -[5162, 0.50000, 0.80514, 0.33750], -[5163, 0.58660, 0.57500, 0.00000], -[5164, 0.54005, 0.79472, 0.46000], -[5165, 0.66532, 0.69310, 0.45749], -[5166, 0.62264, 0.72982, 0.43265], -[5167, 0.60470, 0.70441, 0.24884], -[5168, 0.76589, 0.57717, 0.42767], -[5169, 0.78611, 0.55224, 0.45305], -[5170, 0.74058, 0.61327, 0.47184], -[5171, 0.56424, 0.76067, 0.33155], -[5172, 0.71113, 0.64775, 0.48769], -[5173, 0.67643, 0.68367, 0.47780], -[5174, 0.73218, 0.54563, 0.19723], -[5175, 0.63613, 0.63687, 0.16049], -[5176, 0.80311, 0.50000, 0.32500], -[5177, 0.80311, 0.17500, 0.00000], -[5178, 0.71367, 0.58975, 0.23824], -[5179, 0.55981, 0.77743, 0.41096], -[5180, 0.00000, 0.91250, 0.19486], -[5181, 0.91250, 0.00000, 0.19486], -[5182, 0.56677, 0.76987, 0.39074], -[5183, 0.63953, 0.57801, 0.07243], -[5184, 0.69988, 0.64084, 0.34023], -[5185, 0.00000, 0.95000, 0.34641], -[5186, 0.65895, 0.55843, 0.07563], -[5187, 0.56046, 0.73584, 0.23434], -[5188, 0.66185, 0.68371, 0.35625], -[5189, 0.70066, 0.58878, 0.20235], -[5190, 0.73816, 0.50000, 0.13750], -[5191, 0.50000, 0.78349, 0.25000], -[5192, 0.69352, 0.66387, 0.43163], -[5193, 0.66067, 0.63868, 0.21363], -[5194, 0.59601, 0.60312, 0.04449], -[5195, 0.60687, 0.64023, 0.11493], -[5196, 0.56873, 0.64176, 0.06269], -[5197, 0.66143, 0.69643, 0.43584], -[5198, 0.00000, 0.93750, 0.28146], -[5199, 0.93750, 0.00000, 0.28146], -[5200, 0.66041, 0.59920, 0.13738], -[5201, 0.53944, 0.76634, 0.27979], -[5202, 0.58560, 0.75678, 0.39383], -[5203, 0.51249, 0.72398, 0.12538], -[5204, 0.59255, 0.75474, 0.42002], -[5205, 0.66874, 0.68242, 0.38056], -[5206, 0.57166, 0.77186, 0.42971], -[5207, 0.79968, 0.53522, 0.46035], -[5208, 0.61220, 0.58686, 0.04343], -[5209, 0.57049, 0.70440, 0.17435], -[5210, 0.68527, 0.64536, 0.29584], -[5211, 0.60622, 0.68205, 0.19164], -[5212, 0.77888, 0.53389, 0.30998], -[5213, 0.67040, 0.57198, 0.11105], -[5214, 0.76250, 0.58864, 0.50000], -[5215, 0.59806, 0.74525, 0.37795], -[5216, 0.50000, 0.76184, 0.18750], -[5217, 0.67715, 0.66984, 0.35521], -[5218, 0.57446, 0.61509, 0.03110], -[5219, 0.58898, 0.74273, 0.32719], -[5220, 0.73257, 0.56231, 0.22494], -[5221, 0.52165, 0.63750, 0.00000], -[5222, 0.63750, 0.52165, 0.00000], -[5223, 0.62041, 0.69814, 0.26277], -[5224, 0.52499, 0.79381, 0.34859], -[5225, 0.76368, 0.56268, 0.33010], -[5226, 0.69719, 0.65695, 0.39497], -[5227, 0.80553, 0.51706, 0.38827], -[5228, 0.64976, 0.71173, 0.50000], -[5229, 0.56533, 0.78028, 0.48225], -[5230, 0.19689, 0.80000, 0.00000], -[5231, 0.72791, 0.63120, 0.47664], -[5232, 0.67321, 0.50000, 0.02500], -[5233, 0.67321, 0.47500, 0.00000], -[5234, 0.56338, 0.75802, 0.30797], -[5235, 0.76069, 0.54787, 0.27624], -[5236, 0.70249, 0.57819, 0.18208], -[5237, 0.61793, 0.62406, 0.10295], -[5238, 0.62838, 0.65498, 0.17561], -[5239, 0.76185, 0.58437, 0.41432], -[5240, 0.79881, 0.51662, 0.34402], -[5241, 0.78146, 0.50000, 0.23750], -[5242, 0.63457, 0.57085, 0.05119], -[5243, 0.56415, 0.66907, 0.09489], -[5244, 0.64354, 0.71075, 0.39610], -[5245, 0.54844, 0.78020, 0.35614], -[5246, 0.83750, 0.00000, 0.02165], -[5247, 0.00000, 0.83750, 0.02165], -[5248, 0.68922, 0.65412, 0.33452], -[5249, 0.77366, 0.57357, 0.44702], -[5250, 0.70264, 0.65906, 0.45215], -[5251, 0.66234, 0.66198, 0.26842], -[5252, 0.82500, 0.50000, 0.50000], -[5253, 0.82500, 0.00000, 0.00000], -[5254, 0.00000, 0.82500, 0.00000], -[5255, 0.50000, 0.82500, 0.50000], -[5256, 0.69832, 0.56143, 0.14230], -[5257, 0.96458, 0.00000, 0.47779], -[5258, 0.55476, 0.78895, 0.47214], -[5259, 0.28349, 0.77500, 0.00000], -[5260, 0.77500, 0.28349, 0.00000], -[5261, 0.79268, 0.54375, 0.41614], -[5262, 0.85000, 0.00000, 0.04330], -[5263, 0.00000, 0.85000, 0.04330], -[5264, 0.70204, 0.60063, 0.22170], -[5265, 0.58541, 0.63857, 0.07492], -[5266, 0.63953, 0.70133, 0.32567], -[5267, 0.58041, 0.72522, 0.23838], -[5268, 0.68550, 0.58627, 0.15668], -[5269, 0.57123, 0.72478, 0.21734], -[5270, 0.54193, 0.79590, 0.43380], -[5271, 0.00000, 0.96500, 0.48160], -[5272, 0.64453, 0.61782, 0.13328], -[5273, 0.58973, 0.69474, 0.18192], -[5274, 0.82476, 0.50000, 0.46250], -[5275, 0.82476, 0.03750, 0.00000], -[5276, 0.63618, 0.61372, 0.11228], -[5277, 0.68075, 0.64595, 0.27369], -[5278, 0.62701, 0.71607, 0.33804], -[5279, 0.72236, 0.63373, 0.40621], -[5280, 0.52165, 0.81250, 0.50000], -[5281, 0.04330, 0.82500, 0.00000], -[5282, 0.51793, 0.80630, 0.38092], -[5283, 0.67787, 0.60468, 0.17213], -[5284, 0.63414, 0.63365, 0.14078], -[5285, 0.56942, 0.65280, 0.07293], -[5286, 0.62620, 0.55873, 0.02202], -[5287, 0.75981, 0.50000, 0.17500], -[5288, 0.65059, 0.53106, 0.02278], -[5289, 0.15155, 0.81250, 0.00000], -[5290, 0.86250, 0.00000, 0.06495], -[5291, 0.00000, 0.86250, 0.06495], -[5292, 0.67610, 0.55792, 0.09382], -[5293, 0.81033, 0.51875, 0.41250], -[5294, 0.50000, 0.80514, 0.31250], -[5295, 0.64616, 0.68000, 0.26847], -[5296, 0.77836, 0.51340, 0.24670], -[5297, 0.51470, 0.68431, 0.05234], -[5298, 0.53982, 0.80139, 0.50000], -[5299, 0.75373, 0.53407, 0.21654], -[5300, 0.54392, 0.70392, 0.12269], -[5301, 0.62055, 0.65503, 0.15411], -[5302, 0.67386, 0.61836, 0.18798], -[5303, 0.57412, 0.77637, 0.46138], -[5304, 0.62090, 0.67373, 0.19249], -[5305, 0.61047, 0.72817, 0.32372], -[5306, 0.73584, 0.62546, 0.46234], -[5307, 0.82476, 0.50000, 0.43750], -[5308, 0.82476, 0.06250, 0.00000], -[5309, 0.63995, 0.72382, 0.47284], -[5310, 0.50000, 0.82679, 0.47500], -[5311, 0.60996, 0.72299, 0.30135], -[5312, 0.51149, 0.81766, 0.43644], -[5313, 0.62627, 0.72307, 0.36109], -[5314, 0.73525, 0.58050, 0.26171], -[5315, 0.60272, 0.63442, 0.08936], -[5316, 0.52689, 0.76378, 0.22903], -[5317, 0.60420, 0.74249, 0.36449], -[5318, 0.67738, 0.63422, 0.22857], -[5319, 0.81627, 0.51659, 0.45995], -[5320, 0.61054, 0.57463, 0.01838], -[5321, 0.51712, 0.67101, 0.03388], -[5322, 0.75000, 0.61029, 0.50000], -[5323, 0.69207, 0.62461, 0.24334], -[5324, 0.80311, 0.50000, 0.30000], -[5325, 0.80311, 0.20000, 0.00000], -[5326, 0.63082, 0.64433, 0.15085], -[5327, 0.51398, 0.79472, 0.30154], -[5328, 0.72635, 0.60209, 0.28740], -[5329, 0.58758, 0.76782, 0.47791], -[5330, 0.77999, 0.56594, 0.41856], -[5331, 0.55171, 0.78697, 0.39163], -[5332, 0.78916, 0.52107, 0.29658], -[5333, 0.00000, 0.96643, 0.45795], -[5334, 0.54330, 0.62500, 0.00000], -[5335, 0.80114, 0.52586, 0.36752], -[5336, 0.00000, 0.92500, 0.21651], -[5337, 0.92500, 0.00000, 0.21651], -[5338, 0.50000, 0.82679, 0.45000], -[5339, 0.71991, 0.55479, 0.16789], -[5340, 0.69005, 0.66607, 0.37137], -[5341, 0.60825, 0.56250, 0.00000], -[5342, 0.50000, 0.71854, 0.08750], -[5343, 0.87500, 0.00000, 0.08660], -[5344, 0.00000, 0.87500, 0.08660], -[5345, 0.55657, 0.78871, 0.43068], -[5346, 0.68513, 0.57268, 0.12663], -[5347, 0.54862, 0.67821, 0.08066], -[5348, 0.57206, 0.71828, 0.19395], -[5349, 0.70309, 0.54239, 0.11474], -[5350, 0.72706, 0.53669, 0.15303], -[5351, 0.70854, 0.64733, 0.37336], -[5352, 0.54202, 0.74902, 0.21310], -[5353, 0.61371, 0.74102, 0.39219], -[5354, 0.79462, 0.55269, 0.47437], -[5355, 0.54791, 0.66292, 0.05510], -[5356, 0.82476, 0.50000, 0.41250], -[5357, 0.82476, 0.08750, 0.00000], -[5358, 0.68570, 0.68254, 0.45682], -[5359, 0.67041, 0.69893, 0.50000], -[5360, 0.71494, 0.54057, 0.13299], -[5361, 0.75120, 0.56795, 0.27369], -[5362, 0.08660, 0.82500, 0.00000], -[5363, 0.50000, 0.69689, 0.05000], -[5364, 0.77279, 0.51558, 0.22570], -[5365, 0.51502, 0.80652, 0.34968], -[5366, 0.55546, 0.64699, 0.04038], -[5367, 0.59646, 0.76109, 0.44174], -[5368, 0.58418, 0.69380, 0.15968], -[5369, 0.64759, 0.67377, 0.24476], -[5370, 0.60716, 0.72057, 0.27499], -[5371, 0.50000, 0.74019, 0.12500], -[5372, 0.76948, 0.58849, 0.48797], -[5373, 0.66576, 0.70360, 0.48179], -[5374, 0.72462, 0.63914, 0.42840], -[5375, 0.26184, 0.78750, 0.00000], -[5376, 0.78750, 0.26184, 0.00000], -[5377, 0.75304, 0.60267, 0.40733], -[5378, 0.77492, 0.58104, 0.47044], -[5379, 0.52815, 0.65592, 0.02055], -[5380, 0.50000, 0.82679, 0.42500], -[5381, 0.66265, 0.57609, 0.08983], -[5382, 0.52473, 0.75411, 0.19137], -[5383, 0.71838, 0.58546, 0.21618], -[5384, 0.66502, 0.62460, 0.17281], -[5385, 0.70231, 0.66749, 0.47387], -[5386, 0.50000, 0.78349, 0.22500], -[5387, 0.55321, 0.77896, 0.33664], -[5388, 0.53703, 0.65964, 0.03514], -[5389, 0.94959, 0.00000, 0.30471], -[5390, 0.51253, 0.76643, 0.20024], -[5391, 0.68697, 0.65848, 0.31381], -[5392, 0.71371, 0.62380, 0.29578], -[5393, 0.65616, 0.62532, 0.15544], -[5394, 0.63873, 0.66947, 0.20976], -[5395, 0.73893, 0.62509, 0.43959], -[5396, 0.71475, 0.63959, 0.35655], -[5397, 0.54105, 0.72738, 0.15543], -[5398, 0.69967, 0.63522, 0.28158], -[5399, 0.63174, 0.61116, 0.08990], -[5400, 0.82345, 0.51233, 0.48095], -[5401, 0.58160, 0.77083, 0.40786], -[5402, 0.72440, 0.63320, 0.37638], -[5403, 0.65576, 0.70204, 0.36522], -[5404, 0.88750, 0.00000, 0.10825], -[5405, 0.00000, 0.88750, 0.10825], -[5406, 0.67533, 0.69203, 0.42111], -[5407, 0.00000, 0.95000, 0.30311], -[5408, 0.55872, 0.72421, 0.17635], -[5409, 0.60980, 0.74888, 0.40629], -[5410, 0.67890, 0.59254, 0.14019], -[5411, 0.60244, 0.71356, 0.23644], -[5412, 0.51875, 0.74741, 0.16250], -[5413, 0.73274, 0.60699, 0.30891], -[5414, 0.56131, 0.63238, 0.02366], -[5415, 0.65529, 0.71431, 0.45238], -[5416, 0.71501, 0.62958, 0.31366], -[5417, 0.74091, 0.58679, 0.27839], -[5418, 0.67556, 0.66389, 0.28709], -[5419, 0.77475, 0.56602, 0.35173], -[5420, 0.62946, 0.59232, 0.05756], -[5421, 0.59660, 0.74188, 0.30888], -[5422, 0.56310, 0.78947, 0.44998], -[5423, 0.61257, 0.73724, 0.34471], -[5424, 0.82476, 0.50000, 0.38750], -[5425, 0.82476, 0.11250, 0.00000], -[5426, 0.73750, 0.63194, 0.50000], -[5427, 0.95952, 0.00000, 0.34955], -[5428, 0.78146, 0.50000, 0.21250], -[5429, 0.53198, 0.77970, 0.27105], -[5430, 0.50000, 0.80514, 0.28750], -[5431, 0.51819, 0.71967, 0.10372], -[5432, 0.75787, 0.54683, 0.23517], -[5433, 0.50000, 0.82679, 0.40000], -[5434, 0.64175, 0.56372, 0.03737], -[5435, 0.95637, 0.00000, 0.32963], -[5436, 0.55609, 0.69048, 0.10290], -[5437, 0.65695, 0.54654, 0.03804], -[5438, 0.64754, 0.65646, 0.19381], -[5439, 0.71651, 0.50000, 0.07500], -[5440, 0.71651, 0.42500, 0.00000], -[5441, 0.72232, 0.56630, 0.18111], -[5442, 0.60475, 0.62380, 0.06491], -[5443, 0.66593, 0.65404, 0.22983], -[5444, 0.50000, 0.76184, 0.16250], -[5445, 0.56495, 0.61250, 0.00000], -[5446, 0.96964, 0.00000, 0.43575], -[5447, 0.58045, 0.76911, 0.37399], -[5448, 0.72285, 0.60406, 0.26123], -[5449, 0.63003, 0.73188, 0.39073], -[5450, 0.69862, 0.54483, 0.10036], -[5451, 0.53745, 0.70627, 0.10378], -[5452, 0.74029, 0.51922, 0.14357], -[5453, 0.67240, 0.58858, 0.11774], -[5454, 0.58660, 0.77500, 0.50000], -[5455, 0.65849, 0.70840, 0.40354], -[5456, 0.75802, 0.55706, 0.25537], -[5457, 0.73816, 0.50000, 0.11250], -[5458, 0.79505, 0.53635, 0.34105], -[5459, 0.80731, 0.53311, 0.40459], -[5460, 0.67141, 0.54499, 0.05581], -[5461, 0.53014, 0.81436, 0.46990], -[5462, 0.54931, 0.79190, 0.37143], -[5463, 0.75031, 0.60758, 0.38459], -[5464, 0.78431, 0.56266, 0.38271], -[5465, 0.54042, 0.76997, 0.25386], -[5466, 0.65765, 0.70627, 0.38090], -[5467, 0.80311, 0.50000, 0.27500], -[5468, 0.57288, 0.74535, 0.25115], -[5469, 0.72186, 0.52401, 0.11268], -[5470, 0.76423, 0.56424, 0.29188], -[5471, 0.59688, 0.66399, 0.11448], -[5472, 0.69453, 0.61051, 0.19879], -[5473, 0.53404, 0.73810, 0.15956], -[5474, 0.53076, 0.69273, 0.07052], -[5475, 0.66841, 0.69930, 0.39798], -[5476, 0.66841, 0.67873, 0.30307], -[5477, 0.70791, 0.61412, 0.23931], -[5478, 0.53898, 0.80523, 0.41304], -[5479, 0.77408, 0.57679, 0.37915], -[5480, 0.41340, 0.72500, 0.00000], -[5481, 0.80030, 0.52074, 0.31325], -[5482, 0.63337, 0.73716, 0.45547], -[5483, 0.74458, 0.52852, 0.16412], -[5484, 0.69424, 0.66447, 0.34805], -[5485, 0.61679, 0.69332, 0.20732], -[5486, 0.54534, 0.74260, 0.18702], -[5487, 0.43505, 0.71250, 0.00000], -[5488, 0.60427, 0.70728, 0.21443], -[5489, 0.75510, 0.57966, 0.29809], -[5490, 0.60582, 0.68778, 0.17305], -[5491, 0.90000, 0.00000, 0.12990], -[5492, 0.00000, 0.90000, 0.12990], -[5493, 0.58844, 0.71588, 0.20279], -[5494, 0.71345, 0.65785, 0.42646], -[5495, 0.62612, 0.57939, 0.03147], -[5496, 0.39175, 0.73750, 0.00000], -[5497, 0.73750, 0.39175, 0.00000], -[5498, 0.68308, 0.54757, 0.07454], -[5499, 0.00000, 0.93750, 0.23816], -[5500, 0.93750, 0.00000, 0.23816], -[5501, 0.12990, 0.82500, 0.00000], -[5502, 0.00000, 0.96458, 0.36922], -[5503, 0.80225, 0.23234, 0.00000], -[5504, 0.65907, 0.59278, 0.09761], -[5505, 0.24019, 0.80000, 0.00000], -[5506, 0.60610, 0.67947, 0.15538], -[5507, 0.62844, 0.74324, 0.47701], -[5508, 0.58352, 0.68501, 0.12826], -[5509, 0.67633, 0.68034, 0.33364], -[5510, 0.00000, 0.96964, 0.41169], -[5511, 0.57199, 0.63935, 0.03944], -[5512, 0.68761, 0.62465, 0.20835], -[5513, 0.62943, 0.63712, 0.11793], -[5514, 0.75394, 0.61454, 0.45339], -[5515, 0.76141, 0.60310, 0.43047], -[5516, 0.52235, 0.78172, 0.24595], -[5517, 0.71553, 0.65392, 0.40568], -[5518, 0.54033, 0.78259, 0.28999], -[5519, 0.45670, 0.70000, 0.00000], -[5520, 0.78785, 0.52767, 0.27763], -[5521, 0.69100, 0.68642, 0.50000], -[5522, 0.52050, 0.81885, 0.41333], -[5523, 0.65522, 0.70293, 0.34024], -[5524, 0.63707, 0.70666, 0.29075], -[5525, 0.80441, 0.54619, 0.43975], -[5526, 0.53318, 0.80392, 0.36395], -[5527, 0.82476, 0.50000, 0.36250], -[5528, 0.82476, 0.13750, 0.00000], -[5529, 0.50000, 0.82679, 0.37500], -[5530, 0.63024, 0.71976, 0.31561], -[5531, 0.77224, 0.53963, 0.25153], -[5532, 0.61998, 0.70052, 0.22746], -[5533, 0.37010, 0.75000, 0.00000], -[5534, 0.75000, 0.37010, 0.00000], -[5535, 0.60971, 0.66573, 0.13319], -[5536, 0.56463, 0.78441, 0.37570], -[5537, 0.63496, 0.69013, 0.23498], -[5538, 0.75981, 0.50000, 0.15000], -[5539, 0.69571, 0.50000, 0.03542], -[5540, 0.69571, 0.46458, 0.00000], -[5541, 0.58107, 0.76045, 0.31574], -[5542, 0.69387, 0.56157, 0.10853], -[5543, 0.61386, 0.75659, 0.47005], -[5544, 0.63694, 0.68248, 0.21930], -[5545, 0.69120, 0.67899, 0.39269], -[5546, 0.67406, 0.53123, 0.03762], -[5547, 0.69868, 0.59290, 0.16722], -[5548, 0.63181, 0.54889, 0.00000], -[5549, 0.66970, 0.63695, 0.18974], -[5550, 0.00000, 0.97500, 0.50000], -[5551, 0.97500, 0.00000, 0.50000], -[5552, 0.51167, 0.70565, 0.06301], -[5553, 0.53387, 0.72200, 0.11998], -[5554, 0.68830, 0.51299, 0.03750], -[5555, 0.56549, 0.69742, 0.11967], -[5556, 0.76119, 0.58608, 0.33271], -[5557, 0.59565, 0.73154, 0.25289], -[5558, 0.52427, 0.73790, 0.13707], -[5559, 0.66110, 0.60743, 0.11913], -[5560, 0.52013, 0.79648, 0.28509], -[5561, 0.66635, 0.68831, 0.31695], -[5562, 0.60825, 0.76250, 0.50000], -[5563, 0.47835, 0.68750, 0.00000], -[5564, 0.73435, 0.56804, 0.20056], -[5565, 0.60090, 0.76032, 0.38811], -[5566, 0.56388, 0.79609, 0.50000], -[5567, 0.62478, 0.61221, 0.06804], -[5568, 0.02165, 0.83750, 0.00000], -[5569, 0.64548, 0.55107, 0.01875], -[5570, 0.64364, 0.73093, 0.44164], -[5571, 0.56068, 0.76201, 0.26119], -[5572, 0.73121, 0.64415, 0.44981], -[5573, 0.55282, 0.77995, 0.30437], -[5574, 0.71199, 0.57254, 0.15709], -[5575, 0.97500, 0.00000, 0.45670], -[5576, 0.67980, 0.68592, 0.35838], -[5577, 0.78672, 0.57774, 0.49114], -[5578, 0.72500, 0.65359, 0.50000], -[5579, 0.34845, 0.76250, 0.00000], -[5580, 0.76250, 0.34845, 0.00000], -[5581, 0.70538, 0.66906, 0.41267], -[5582, 0.71083, 0.62230, 0.25416], -[5583, 0.79707, 0.54872, 0.37068], -[5584, 0.51333, 0.82985, 0.46833], -[5585, 0.74198, 0.62912, 0.41719], -[5586, 0.75156, 0.59497, 0.31423], -[5587, 0.97012, 0.00000, 0.38945], -[5588, 0.73239, 0.58486, 0.22624], -[5589, 0.74299, 0.61010, 0.32922], -[5590, 0.78012, 0.55629, 0.31169], -[5591, 0.58001, 0.77081, 0.34824], -[5592, 0.56812, 0.70618, 0.13636], -[5593, 0.50832, 0.67935, 0.01633], -[5594, 0.50000, 0.78349, 0.20000], -[5595, 0.78566, 0.55613, 0.33411], -[5596, 0.91250, 0.00000, 0.15155], -[5597, 0.00000, 0.91250, 0.15155], -[5598, 0.58660, 0.60000, 0.00000], -[5599, 0.58800, 0.65968, 0.08375], -[5600, 0.79079, 0.57234, 0.46312], -[5601, 0.73368, 0.59353, 0.24735], -[5602, 0.56219, 0.74495, 0.21112], -[5603, 0.54039, 0.80583, 0.38559], -[5604, 0.50000, 0.80514, 0.26250], -[5605, 0.81881, 0.52842, 0.42901], -[5606, 0.78041, 0.54845, 0.28796], -[5607, 0.51866, 0.76315, 0.17835], -[5608, 0.82500, 0.52369, 0.50000], -[5609, 0.70448, 0.64748, 0.30121], -[5610, 0.55132, 0.80541, 0.44993], -[5611, 0.56701, 0.76586, 0.28293], -[5612, 0.64341, 0.73126, 0.41864], -[5613, 0.64296, 0.72495, 0.37192], -[5614, 0.59403, 0.74079, 0.26816], -[5615, 0.55868, 0.75834, 0.23861], -[5616, 0.52646, 0.80312, 0.31721], -[5617, 0.76608, 0.57768, 0.31288], -[5618, 0.06495, 0.83750, 0.00000], -[5619, 0.67500, 0.50000, 0.00000], -[5620, 0.50000, 0.67500, 0.00000], -[5621, 0.57598, 0.68492, 0.10657], -[5622, 0.61801, 0.75568, 0.44753], -[5623, 0.75288, 0.60911, 0.36611], -[5624, 0.50000, 0.82679, 0.35000], -[5625, 0.78850, 0.52387, 0.25496], -[5626, 0.78903, 0.56963, 0.40326], -[5627, 0.61616, 0.61109, 0.04909], -[5628, 0.70840, 0.65623, 0.34461], -[5629, 0.82476, 0.50000, 0.33750], -[5630, 0.82476, 0.16250, 0.00000], -[5631, 0.72120, 0.58525, 0.19341], -[5632, 0.69399, 0.68459, 0.42013], -[5633, 0.54659, 0.79707, 0.34912], -[5634, 0.69626, 0.68445, 0.43911], -[5635, 0.54997, 0.77577, 0.27039], -[5636, 0.65770, 0.72394, 0.48125], -[5637, 0.75300, 0.53824, 0.18315], -[5638, 0.00000, 0.96250, 0.32476], -[5639, 0.62409, 0.67557, 0.16639], -[5640, 0.61181, 0.72337, 0.25572], -[5641, 0.68275, 0.69875, 0.44634], -[5642, 0.72804, 0.51190, 0.09351], -[5643, 0.65280, 0.65092, 0.17215], -[5644, 0.74794, 0.57367, 0.23765], -[5645, 0.76720, 0.60653, 0.47035], -[5646, 0.32679, 0.77500, 0.00000], -[5647, 0.77500, 0.32679, 0.00000], -[5648, 0.59100, 0.64186, 0.05710], -[5649, 0.80311, 0.50000, 0.25000], -[5650, 0.71691, 0.52005, 0.08393], -[5651, 0.81250, 0.54534, 0.50000], -[5652, 0.53388, 0.81724, 0.43189], -[5653, 0.51343, 0.74887, 0.13510], -[5654, 0.81892, 0.53320, 0.44798], -[5655, 0.50000, 0.71854, 0.06250], -[5656, 0.75155, 0.55421, 0.20720], -[5657, 0.76996, 0.52401, 0.19941], -[5658, 0.65915, 0.57988, 0.06745], -[5659, 0.75437, 0.60365, 0.34377], -[5660, 0.50000, 0.74019, 0.10000], -[5661, 0.70033, 0.58248, 0.14203], -[5662, 0.21854, 0.81250, 0.00000], -[5663, 0.58913, 0.75259, 0.28891], -[5664, 0.52609, 0.71330, 0.08464], -[5665, 0.66056, 0.66108, 0.20865], -[5666, 0.59471, 0.69313, 0.14762], -[5667, 0.71390, 0.53477, 0.09664], -[5668, 0.78146, 0.50000, 0.18750], -[5669, 0.59677, 0.77494, 0.45813], -[5670, 0.60976, 0.60178, 0.02614], -[5671, 0.81491, 0.54208, 0.47611], -[5672, 0.56503, 0.78607, 0.35371], -[5673, 0.72511, 0.64849, 0.38849], -[5674, 0.79415, 0.55429, 0.35537], -[5675, 0.60261, 0.70723, 0.19089], -[5676, 0.75427, 0.62403, 0.47258], -[5677, 0.76334, 0.51983, 0.17412], -[5678, 0.00000, 0.97721, 0.43553], -[5679, 0.59582, 0.62558, 0.03875], -[5680, 0.77790, 0.59159, 0.43579], -[5681, 0.53550, 0.68109, 0.04322], -[5682, 0.72110, 0.64135, 0.33219], -[5683, 0.70671, 0.60023, 0.18413], -[5684, 0.79951, 0.56188, 0.43148], -[5685, 0.63002, 0.65511, 0.13459], -[5686, 0.81494, 0.51440, 0.32403], -[5687, 0.57529, 0.65374, 0.05125], -[5688, 0.63879, 0.65747, 0.15434], -[5689, 0.59394, 0.72704, 0.21992], -[5690, 0.72182, 0.62290, 0.27431], -[5691, 0.67773, 0.60452, 0.13204], -[5692, 0.00000, 0.95000, 0.25981], -[5693, 0.95000, 0.00000, 0.25981], -[5694, 0.56943, 0.71940, 0.15564], -[5695, 0.63093, 0.74991, 0.50000], -[5696, 0.64138, 0.70448, 0.26995], -[5697, 0.66501, 0.63967, 0.16956], -[5698, 0.17321, 0.82500, 0.00000], -[5699, 0.55876, 0.80032, 0.41099], -[5700, 0.64727, 0.60079, 0.07483], -[5701, 0.79750, 0.54085, 0.32047], -[5702, 0.55098, 0.65222, 0.01848], -[5703, 0.62299, 0.63069, 0.08155], -[5704, 0.55094, 0.72748, 0.14189], -[5705, 0.52165, 0.66250, 0.00000], -[5706, 0.79124, 0.54492, 0.30469], -[5707, 0.50000, 0.69689, 0.02500], -[5708, 0.80000, 0.56699, 0.50000], -[5709, 0.77246, 0.60187, 0.44848], -[5710, 0.69890, 0.68745, 0.47495], -[5711, 0.65650, 0.67526, 0.22644], -[5712, 0.50000, 0.76184, 0.13750], -[5713, 0.77039, 0.59693, 0.39028], -[5714, 0.52691, 0.82576, 0.45026], -[5715, 0.72215, 0.66323, 0.47490], -[5716, 0.61785, 0.75415, 0.39232], -[5717, 0.65054, 0.72633, 0.39353], -[5718, 0.62012, 0.71459, 0.24116], -[5719, 0.59055, 0.71085, 0.17094], -[5720, 0.52558, 0.82825, 0.48760], -[5721, 0.00000, 0.92500, 0.17321], -[5722, 0.92500, 0.00000, 0.17321], -[5723, 0.68686, 0.70039, 0.48628], -[5724, 0.53887, 0.81974, 0.48710], -[5725, 0.57364, 0.78936, 0.39750], -[5726, 0.73703, 0.62813, 0.34213], -[5727, 0.82254, 0.51967, 0.37308], -[5728, 0.57693, 0.78965, 0.42010], -[5729, 0.51894, 0.82032, 0.35643], -[5730, 0.81229, 0.51456, 0.30416], -[5731, 0.63200, 0.70903, 0.25339], -[5732, 0.70722, 0.65668, 0.32219], -[5733, 0.61325, 0.76256, 0.42615], -[5734, 0.10825, 0.83750, 0.00000], -[5735, 0.30514, 0.78750, 0.00000], -[5736, 0.78750, 0.30514, 0.00000], -[5737, 0.60375, 0.75839, 0.34623], -[5738, 0.71043, 0.67571, 0.45451], -[5739, 0.69575, 0.61239, 0.17687], -[5740, 0.71250, 0.67524, 0.50000], -[5741, 0.59537, 0.77694, 0.42516], -[5742, 0.60397, 0.65797, 0.09249], -[5743, 0.74877, 0.62297, 0.37732], -[5744, 0.59092, 0.76561, 0.33115], -[5745, 0.57455, 0.77867, 0.33417], -[5746, 0.97795, 0.00000, 0.41272], -[5747, 0.56708, 0.77990, 0.31500], -[5748, 0.66226, 0.72175, 0.43181], -[5749, 0.50000, 0.82679, 0.32500], -[5750, 0.81300, 0.53810, 0.38291], -[5751, 0.66396, 0.56556, 0.04883], -[5752, 0.60432, 0.76840, 0.40581], -[5753, 0.57625, 0.66992, 0.07136], -[5754, 0.62015, 0.74961, 0.36507], -[5755, 0.66247, 0.68487, 0.26134], -[5756, 0.72723, 0.55782, 0.14656], -[5757, 0.80430, 0.55441, 0.39653], -[5758, 0.73816, 0.50000, 0.08750], -[5759, 0.63397, 0.73588, 0.35293], -[5760, 0.60825, 0.58750, 0.00000], -[5761, 0.66984, 0.68262, 0.27513], -[5762, 0.71036, 0.66414, 0.36005], -[5763, 0.63254, 0.69529, 0.21401], -[5764, 0.62160, 0.64626, 0.09837], -[5765, 0.78816, 0.58156, 0.42286], -[5766, 0.68643, 0.70214, 0.46552], -[5767, 0.82476, 0.50000, 0.31250], -[5768, 0.82476, 0.18750, 0.00000], -[5769, 0.57995, 0.74433, 0.22566], -[5770, 0.65337, 0.61182, 0.09437], -[5771, 0.62893, 0.72039, 0.27362], -[5772, 0.83296, 0.51564, 0.42183], -[5773, 0.71651, 0.50000, 0.05000], -[5774, 0.71651, 0.45000, 0.00000], -[5775, 0.82513, 0.52455, 0.39987], -[5776, 0.53171, 0.81066, 0.33825], -[5777, 0.60926, 0.74158, 0.28789], -[5778, 0.58433, 0.78827, 0.44180], -[5779, 0.53475, 0.76611, 0.19446], -[5780, 0.54214, 0.74931, 0.16676], -[5781, 0.68613, 0.60777, 0.14458], -[5782, 0.00000, 0.97685, 0.38912], -[5783, 0.72411, 0.60566, 0.22542], -[5784, 0.56427, 0.66774, 0.05016], -[5785, 0.78750, 0.58864, 0.50000], -[5786, 0.67869, 0.57011, 0.07453], -[5787, 0.75887, 0.61626, 0.39460], -[5788, 0.67205, 0.59762, 0.10252], -[5789, 0.74864, 0.60286, 0.29286], -[5790, 0.54701, 0.79839, 0.32631], -[5791, 0.84641, 0.50000, 0.47500], -[5792, 0.84641, 0.02500, 0.00000], -[5793, 0.59779, 0.61476, 0.01859], -[5794, 0.65186, 0.73636, 0.50000], -[5795, 0.50000, 0.80514, 0.23750], -[5796, 0.59815, 0.76912, 0.36574], -[5797, 0.66775, 0.62116, 0.13150], -[5798, 0.56824, 0.74045, 0.18944], -[5799, 0.54330, 0.65000, 0.00000], -[5800, 0.58236, 0.75816, 0.26769], -[5801, 0.75981, 0.50000, 0.12500], -[5802, 0.51423, 0.81425, 0.29839], -[5803, 0.58825, 0.67404, 0.09049], -[5804, 0.65944, 0.71591, 0.35591], -[5805, 0.65846, 0.69938, 0.28664], -[5806, 0.55028, 0.70126, 0.08323], -[5807, 0.68044, 0.65024, 0.21245], -[5808, 0.66029, 0.70684, 0.31851], -[5809, 0.74602, 0.55836, 0.18333], -[5810, 0.68455, 0.66737, 0.26629], -[5811, 0.52375, 0.75720, 0.15217], -[5812, 0.74276, 0.64513, 0.47197], -[5813, 0.68488, 0.57912, 0.09473], -[5814, 0.84641, 0.50000, 0.45000], -[5815, 0.84641, 0.05000, 0.00000], -[5816, 0.61231, 0.75092, 0.32627], -[5817, 0.80057, 0.53333, 0.29092], -[5818, 0.70154, 0.65607, 0.28373], -[5819, 0.63206, 0.59458, 0.03485], -[5820, 0.19689, 0.82500, 0.00000], -[5821, 0.63638, 0.68724, 0.19646], -[5822, 0.67188, 0.67215, 0.24264], -[5823, 0.50000, 0.78349, 0.17500], -[5824, 0.56437, 0.80662, 0.47784], -[5825, 0.58095, 0.77018, 0.30229], -[5826, 0.69754, 0.67327, 0.32689], -[5827, 0.51989, 0.69360, 0.03253], -[5828, 0.69974, 0.65077, 0.26171], -[5829, 0.71733, 0.60387, 0.19882], -[5830, 0.64771, 0.72228, 0.33029], -[5831, 0.63044, 0.73741, 0.33029], -[5832, 0.65307, 0.54183, 0.00000], -[5833, 0.62262, 0.69438, 0.18335], -[5834, 0.79528, 0.51533, 0.23150], -[5835, 0.69337, 0.58439, 0.11540], -[5836, 0.28349, 0.80000, 0.00000], -[5837, 0.80000, 0.28349, 0.00000], -[5838, 0.64412, 0.67164, 0.17692], -[5839, 0.73592, 0.62954, 0.31923], -[5840, 0.80311, 0.50000, 0.22500], -[5841, 0.70535, 0.53126, 0.06300], -[5842, 0.55520, 0.71643, 0.11363], -[5843, 0.66939, 0.72235, 0.46862], -[5844, 0.52263, 0.74025, 0.11287], -[5845, 0.81134, 0.55703, 0.45050], -[5846, 0.50000, 0.84845, 0.46250], -[5847, 0.58835, 0.79019, 0.47288], -[5848, 0.77347, 0.56576, 0.26986], -[5849, 0.76167, 0.62022, 0.41937], -[5850, 0.97586, 0.00000, 0.36201], -[5851, 0.73938, 0.63629, 0.35926], -[5852, 0.75497, 0.58704, 0.26167], -[5853, 0.63640, 0.74956, 0.43041], -[5854, 0.69337, 0.64138, 0.21788], -[5855, 0.71341, 0.66997, 0.38201], -[5856, 0.58405, 0.63306, 0.02051], -[5857, 0.52719, 0.78104, 0.21019], -[5858, 0.67944, 0.71054, 0.42582], -[5859, 0.00000, 0.93750, 0.19486], -[5860, 0.93750, 0.00000, 0.19486], -[5861, 0.84641, 0.50000, 0.42500], -[5862, 0.84641, 0.07500, 0.00000], -[5863, 0.77916, 0.54028, 0.22965], -[5864, 0.68856, 0.65360, 0.23366], -[5865, 0.72122, 0.58702, 0.17211], -[5866, 0.85000, 0.50000, 0.50000], -[5867, 0.85000, 0.00000, 0.00000], -[5868, 0.00000, 0.85000, 0.00000], -[5869, 0.50000, 0.85000, 0.50000], -[5870, 0.67208, 0.70211, 0.33304], -[5871, 0.73633, 0.62223, 0.29210], -[5872, 0.74514, 0.64259, 0.43358], -[5873, 0.62324, 0.58956, 0.01361], -[5874, 0.74915, 0.57456, 0.21484], -[5875, 0.57125, 0.68819, 0.08434], -[5876, 0.86250, 0.00000, 0.02165], -[5877, 0.00000, 0.86250, 0.02165], -[5878, 0.71500, 0.57213, 0.13367], -[5879, 0.62291, 0.74043, 0.30881], -[5880, 0.77129, 0.59813, 0.35802], -[5881, 0.70448, 0.51833, 0.04404], -[5882, 0.80667, 0.51958, 0.27130], -[5883, 0.62417, 0.67655, 0.14542], -[5884, 0.77500, 0.61029, 0.50000], -[5885, 0.71791, 0.55782, 0.11722], -[5886, 0.76189, 0.52071, 0.15122], -[5887, 0.59830, 0.73961, 0.23863], -[5888, 0.81371, 0.55192, 0.41882], -[5889, 0.74612, 0.63711, 0.39628], -[5890, 0.52165, 0.83750, 0.50000], -[5891, 0.50000, 0.82679, 0.30000], -[5892, 0.69714, 0.56200, 0.08555], -[5893, 0.58300, 0.73888, 0.20356], -[5894, 0.69169, 0.63156, 0.18944], -[5895, 0.50000, 0.84845, 0.43750], -[5896, 0.68015, 0.52571, 0.01544], -[5897, 0.77558, 0.60368, 0.41160], -[5898, 0.74467, 0.55391, 0.16432], -[5899, 0.87500, 0.00000, 0.04330], -[5900, 0.00000, 0.87500, 0.04330], -[5901, 0.00000, 0.97500, 0.34641], -[5902, 0.82780, 0.53610, 0.45882], -[5903, 0.15155, 0.83750, 0.00000], -[5904, 0.04330, 0.85000, 0.00000], -[5905, 0.78146, 0.50000, 0.16250], -[5906, 0.74410, 0.41349, 0.00000], -[5907, 0.67149, 0.72373, 0.50000], -[5908, 0.74147, 0.61112, 0.27267], -[5909, 0.64709, 0.64677, 0.12860], -[5910, 0.70091, 0.68206, 0.36386], -[5911, 0.64233, 0.57330, 0.01645], -[5912, 0.69309, 0.51107, 0.01676], -[5913, 0.66754, 0.54492, 0.01773], -[5914, 0.70151, 0.66735, 0.30576], -[5915, 0.54200, 0.78151, 0.23407], -[5916, 0.52317, 0.80208, 0.25867], -[5917, 0.69248, 0.54005, 0.04812], -[5918, 0.82476, 0.50000, 0.28750], -[5919, 0.75297, 0.63747, 0.45288], -[5920, 0.56495, 0.63750, 0.00000], -[5921, 0.67428, 0.63158, 0.15064], -[5922, 0.78426, 0.53057, 0.21884], -[5923, 0.72813, 0.65427, 0.36806], -[5924, 0.56347, 0.73851, 0.16409], -[5925, 0.82466, 0.21417, 0.00000], -[5926, 0.73088, 0.54457, 0.11887], -[5927, 0.65079, 0.67766, 0.19425], -[5928, 0.77306, 0.55788, 0.24028], -[5929, 0.71023, 0.62328, 0.21105], -[5930, 0.84641, 0.50000, 0.40000], -[5931, 0.84641, 0.10000, 0.00000], -[5932, 0.60777, 0.77887, 0.47798], -[5933, 0.79210, 0.57521, 0.36474], -[5934, 0.82140, 0.54520, 0.43149], -[5935, 0.56026, 0.66611, 0.03194], -[5936, 0.64332, 0.63150, 0.09490], -[5937, 0.53129, 0.82399, 0.37492], -[5938, 0.88750, 0.00000, 0.06495], -[5939, 0.00000, 0.88750, 0.06495], -[5940, 0.72947, 0.64942, 0.34787], -[5941, 0.54751, 0.82220, 0.46452], -[5942, 0.65890, 0.62830, 0.11503], -[5943, 0.78043, 0.58959, 0.35690], -[5944, 0.52940, 0.70242, 0.04878], -[5945, 0.65012, 0.74411, 0.46950], -[5946, 0.62990, 0.57500, 0.00000], -[5947, 0.71083, 0.54427, 0.08051], -[5948, 0.50000, 0.84845, 0.41250], -[5949, 0.65798, 0.64974, 0.14981], -[5950, 0.78937, 0.59381, 0.45508], -[5951, 0.76088, 0.62801, 0.43351], -[5952, 0.59852, 0.68422, 0.11089], -[5953, 0.71064, 0.63429, 0.23402], -[5954, 0.71380, 0.55586, 0.10011], -[5955, 0.65162, 0.70148, 0.25143], -[5956, 0.50000, 0.74019, 0.07500], -[5957, 0.82742, 0.51917, 0.34371], -[5958, 0.69214, 0.69636, 0.37912], -[5959, 0.52248, 0.83733, 0.43302], -[5960, 0.00000, 0.96458, 0.28038], -[5961, 0.26184, 0.81250, 0.00000], -[5962, 0.81250, 0.26184, 0.00000], -[5963, 0.72874, 0.66738, 0.45145], -[5964, 0.67321, 0.52500, 0.00000], -[5965, 0.63572, 0.72945, 0.29323], -[5966, 0.58392, 0.78684, 0.36242], -[5967, 0.80800, 0.57095, 0.47826], -[5968, 0.75229, 0.53685, 0.14592], -[5969, 0.78497, 0.57711, 0.32555], -[5970, 0.73438, 0.57123, 0.16223], -[5971, 0.59352, 0.78353, 0.38301], -[5972, 0.08660, 0.85000, 0.00000], -[5973, 0.71743, 0.68138, 0.46772], -[5974, 0.56336, 0.80600, 0.38573], -[5975, 0.51974, 0.82403, 0.32392], -[5976, 0.84331, 0.51679, 0.45544], -[5977, 0.51444, 0.83808, 0.38483], -[5978, 0.58314, 0.73205, 0.17695], -[5979, 0.72119, 0.67433, 0.42590], -[5980, 0.68660, 0.63187, 0.16887], -[5981, 0.50000, 0.76184, 0.11250], -[5982, 0.63466, 0.75920, 0.46172], -[5983, 0.78427, 0.51398, 0.18153], -[5984, 0.76250, 0.63194, 0.50000], -[5985, 0.58607, 0.71046, 0.13596], -[5986, 0.77799, 0.60949, 0.43664], -[5987, 0.90000, 0.00000, 0.08660], -[5988, 0.00000, 0.90000, 0.08660], -[5989, 0.50000, 0.80514, 0.21250], -[5990, 0.71299, 0.59256, 0.15145], -[5991, 0.64492, 0.74545, 0.40311], -[5992, 0.62074, 0.64853, 0.08155], -[5993, 0.65322, 0.71790, 0.30259], -[5994, 0.69169, 0.70238, 0.40365], -[5995, 0.56897, 0.80961, 0.45670], -[5996, 0.54854, 0.77269, 0.21161], -[5997, 0.51563, 0.73865, 0.08809], -[5998, 0.74186, 0.52347, 0.10403], -[5999, 0.64712, 0.59927, 0.04908], -[6000, 0.68092, 0.71764, 0.44942], -[6001, 0.56585, 0.79686, 0.33856], -[6002, 0.73947, 0.65369, 0.41546], -[6003, 0.55182, 0.71510, 0.09326], -[6004, 0.53622, 0.80780, 0.29694], -[6005, 0.62034, 0.66588, 0.10872], -[6006, 0.79539, 0.59010, 0.47693], -[6007, 0.51875, 0.79793, 0.22500], -[6008, 0.56837, 0.80841, 0.43021], -[6009, 0.54073, 0.79293, 0.25395], -[6010, 0.70652, 0.69457, 0.49083], -[6011, 0.74196, 0.64533, 0.37854], -[6012, 0.66691, 0.60215, 0.08238], -[6013, 0.80334, 0.56541, 0.37071], -[6014, 0.73375, 0.61873, 0.25360], -[6015, 0.84641, 0.50000, 0.37500], -[6016, 0.84641, 0.12500, 0.00000], -[6017, 0.61729, 0.61930, 0.03356], -[6018, 0.63477, 0.69055, 0.18002], -[6019, 0.66164, 0.56550, 0.02599], -[6020, 0.64136, 0.64593, 0.10783], -[6021, 0.60481, 0.72643, 0.20178], -[6022, 0.50000, 0.84845, 0.38750], -[6023, 0.67867, 0.55365, 0.03582], -[6024, 0.65152, 0.58431, 0.03438], -[6025, 0.00000, 0.95000, 0.21651], -[6026, 0.95000, 0.00000, 0.21651], -[6027, 0.70238, 0.69822, 0.45497], -[6028, 0.76959, 0.55831, 0.21913], -[6029, 0.57474, 0.65483, 0.02685], -[6030, 0.72520, 0.64168, 0.28709], -[6031, 0.61479, 0.72703, 0.22340], -[6032, 0.70963, 0.61926, 0.19001], -[6033, 0.43505, 0.73750, 0.00000], -[6034, 0.63159, 0.75819, 0.40271], -[6035, 0.67471, 0.59230, 0.07891], -[6036, 0.41340, 0.75000, 0.00000], -[6037, 0.54067, 0.80050, 0.27563], -[6038, 0.53115, 0.83148, 0.40002], -[6039, 0.53801, 0.73029, 0.09912], -[6040, 0.52149, 0.78375, 0.18811], -[6041, 0.97835, 0.00000, 0.33750], -[6042, 0.50000, 0.71962, 0.03542], -[6043, 0.64367, 0.62349, 0.07463], -[6044, 0.68530, 0.69533, 0.32371], -[6045, 0.45670, 0.72500, 0.00000], -[6046, 0.50000, 0.82679, 0.27500], -[6047, 0.57028, 0.70584, 0.09900], -[6048, 0.62296, 0.71237, 0.20214], -[6049, 0.69195, 0.71118, 0.50000], -[6050, 0.66448, 0.73524, 0.45026], -[6051, 0.75314, 0.61748, 0.30999], -[6052, 0.69443, 0.69081, 0.34137], -[6053, 0.54055, 0.81982, 0.35736], -[6054, 0.58660, 0.62500, 0.00000], -[6055, 0.75553, 0.52371, 0.12628], -[6056, 0.39175, 0.76250, 0.00000], -[6057, 0.76250, 0.39175, 0.00000], -[6058, 0.53467, 0.83552, 0.46856], -[6059, 0.80311, 0.50000, 0.20000], -[6060, 0.73805, 0.66049, 0.43541], -[6061, 0.79964, 0.54138, 0.27031], -[6062, 0.55127, 0.69839, 0.05984], -[6063, 0.74133, 0.58975, 0.20325], -[6064, 0.82932, 0.53876, 0.41345], -[6065, 0.53673, 0.68514, 0.02234], -[6066, 0.59494, 0.78934, 0.40585], -[6067, 0.74030, 0.58056, 0.18231], -[6068, 0.76573, 0.60804, 0.32671], -[6069, 0.55000, 0.82679, 0.50000], -[6070, 0.91250, 0.00000, 0.10825], -[6071, 0.00000, 0.91250, 0.10825], -[6072, 0.82417, 0.54423, 0.39635], -[6073, 0.73816, 0.50000, 0.06250], -[6074, 0.73816, 0.43750, 0.00000], -[6075, 0.50000, 0.78349, 0.15000], -[6076, 0.59635, 0.75387, 0.24999], -[6077, 0.47835, 0.71250, 0.00000], -[6078, 0.82476, 0.50000, 0.26250], -[6079, 0.66539, 0.72704, 0.37605], -[6080, 0.69814, 0.61736, 0.15620], -[6081, 0.55975, 0.78122, 0.24863], -[6082, 0.57801, 0.76737, 0.24711], -[6083, 0.57408, 0.78545, 0.29856], -[6084, 0.66549, 0.66636, 0.18346], -[6085, 0.97578, 0.00000, 0.31283], -[6086, 0.58665, 0.70345, 0.11493], -[6087, 0.69094, 0.68059, 0.28395], -[6088, 0.75981, 0.50000, 0.10000], -[6089, 0.97006, 0.00000, 0.28476], -[6090, 0.77851, 0.58190, 0.29337], -[6091, 0.79134, 0.56569, 0.29707], -[6092, 0.63939, 0.71379, 0.23707], -[6093, 0.73018, 0.52580, 0.07816], -[6094, 0.80835, 0.55470, 0.33733], -[6095, 0.37010, 0.77500, 0.00000], -[6096, 0.77500, 0.37010, 0.00000], -[6097, 0.67928, 0.71724, 0.39147], -[6098, 0.62641, 0.75554, 0.34379], -[6099, 0.51527, 0.83429, 0.33822], -[6100, 0.78312, 0.61074, 0.45943], -[6101, 0.67731, 0.67158, 0.22033], -[6102, 0.82192, 0.51619, 0.28559], -[6103, 0.64310, 0.61300, 0.05421], -[6104, 0.55199, 0.81619, 0.36872], -[6105, 0.59335, 0.64812, 0.03513], -[6106, 0.62158, 0.77491, 0.46209], -[6107, 0.24019, 0.82500, 0.00000], -[6108, 0.82500, 0.24019, 0.00000], -[6109, 0.52019, 0.72625, 0.06377], -[6110, 0.84181, 0.52830, 0.47525], -[6111, 0.68135, 0.71206, 0.36920], -[6112, 0.59884, 0.66644, 0.06916], -[6113, 0.61191, 0.70651, 0.16109], -[6114, 0.56578, 0.75208, 0.17948], -[6115, 0.51717, 0.76588, 0.13307], -[6116, 0.79903, 0.58094, 0.38708], -[6117, 0.65032, 0.75039, 0.44742], -[6118, 0.50000, 0.84845, 0.36250], -[6119, 0.68146, 0.65035, 0.18149], -[6120, 0.69877, 0.70380, 0.42783], -[6121, 0.84641, 0.50000, 0.35000], -[6122, 0.84641, 0.15000, 0.00000], -[6123, 0.71651, 0.50000, 0.02500], -[6124, 0.71651, 0.47500, 0.00000], -[6125, 0.75673, 0.63521, 0.38620], -[6126, 0.53859, 0.77063, 0.17570], -[6127, 0.76442, 0.54006, 0.16331], -[6128, 0.12990, 0.85000, 0.00000], -[6129, 0.00000, 0.97500, 0.30311], -[6130, 0.63981, 0.70475, 0.21120], -[6131, 0.67775, 0.71147, 0.34516], -[6132, 0.72900, 0.66936, 0.39940], -[6133, 0.75000, 0.65359, 0.50000], -[6134, 0.82056, 0.54303, 0.35290], -[6135, 0.70000, 0.50000, 0.00000], -[6136, 0.50000, 0.70000, 0.00000], -[6137, 0.55965, 0.79467, 0.28717], -[6138, 0.78720, 0.60851, 0.48869], -[6139, 0.54139, 0.83313, 0.44504], -[6140, 0.79398, 0.59206, 0.40327], -[6141, 0.81936, 0.53241, 0.31089], -[6142, 0.63323, 0.76605, 0.44614], -[6143, 0.52081, 0.84710, 0.45531], -[6144, 0.51694, 0.78221, 0.16565], -[6145, 0.65155, 0.56250, 0.00000], -[6146, 0.77784, 0.54536, 0.20249], -[6147, 0.64212, 0.76055, 0.48340], -[6148, 0.65278, 0.70279, 0.23328], -[6149, 0.55084, 0.81431, 0.34282], -[6150, 0.79745, 0.57455, 0.34111], -[6151, 0.84330, 0.51601, 0.38219], -[6152, 0.55083, 0.82399, 0.40548], -[6153, 0.60726, 0.78704, 0.44201], -[6154, 0.34845, 0.78750, 0.00000], -[6155, 0.78750, 0.34845, 0.00000], -[6156, 0.60477, 0.69818, 0.12802], -[6157, 0.77382, 0.61433, 0.37569], -[6158, 0.71399, 0.69133, 0.43661], -[6159, 0.71252, 0.60929, 0.16386], -[6160, 0.59878, 0.78081, 0.34598], -[6161, 0.68460, 0.61636, 0.12121], -[6162, 0.78146, 0.50000, 0.13750], -[6163, 0.54461, 0.74198, 0.11925], -[6164, 0.69650, 0.56187, 0.06259], -[6165, 0.51938, 0.84968, 0.47846], -[6166, 0.62986, 0.73058, 0.25148], -[6167, 0.65830, 0.74431, 0.43009], -[6168, 0.83744, 0.53581, 0.43798], -[6169, 0.65194, 0.72030, 0.27979], -[6170, 0.54586, 0.75157, 0.14004], -[6171, 0.60468, 0.75854, 0.27309], -[6172, 0.80702, 0.58285, 0.46044], -[6173, 0.76402, 0.58717, 0.24686], -[6174, 0.72350, 0.64231, 0.26216], -[6175, 0.92500, 0.00000, 0.12990], -[6176, 0.00000, 0.92500, 0.12990], -[6177, 0.57449, 0.77967, 0.26617], -[6178, 0.75637, 0.57354, 0.19710], -[6179, 0.53730, 0.71796, 0.06523], -[6180, 0.78860, 0.59677, 0.37628], -[6181, 0.65133, 0.74477, 0.37987], -[6182, 0.61479, 0.77529, 0.38031], -[6183, 0.56302, 0.74585, 0.15343], -[6184, 0.58372, 0.80747, 0.47412], -[6185, 0.58750, 0.80514, 0.50000], -[6186, 0.85087, 0.51214, 0.41445], -[6187, 0.57057, 0.68984, 0.06144], -[6188, 0.77784, 0.53603, 0.18150], -[6189, 0.55813, 0.82319, 0.43125], -[6190, 0.53142, 0.75506, 0.12377], -[6191, 0.75352, 0.59328, 0.22740], -[6192, 0.75888, 0.64098, 0.41400], -[6193, 0.76237, 0.60179, 0.27449], -[6194, 0.52599, 0.81784, 0.27900], -[6195, 0.02165, 0.86250, 0.00000], -[6196, 0.80860, 0.57754, 0.41620], -[6197, 0.64525, 0.73689, 0.31275], -[6198, 0.61330, 0.63987, 0.04296], -[6199, 0.79698, 0.55561, 0.27495], -[6200, 0.61195, 0.65370, 0.06098], -[6201, 0.66736, 0.64690, 0.13846], -[6202, 0.74196, 0.60735, 0.22564], -[6203, 0.71204, 0.69342, 0.41725], -[6204, 0.62967, 0.63609, 0.05995], -[6205, 0.52165, 0.68750, 0.00000], -[6206, 0.76860, 0.63528, 0.47812], -[6207, 0.67638, 0.62004, 0.10894], -[6208, 0.55112, 0.83119, 0.48379], -[6209, 0.60825, 0.61250, 0.00000], -[6210, 0.65609, 0.73812, 0.35869], -[6211, 0.65914, 0.74863, 0.48125], -[6212, 0.57354, 0.80497, 0.36405], -[6213, 0.80230, 0.56775, 0.32835], -[6214, 0.66454, 0.68346, 0.20539], -[6215, 0.72932, 0.65517, 0.31458], -[6216, 0.81084, 0.54735, 0.30358], -[6217, 0.70750, 0.57789, 0.09850], -[6218, 0.61812, 0.71678, 0.18397], -[6219, 0.76826, 0.61952, 0.35252], -[6220, 0.73309, 0.54603, 0.09972], -[6221, 0.56023, 0.80262, 0.30568], -[6222, 0.72198, 0.65886, 0.29870], -[6223, 0.50000, 0.80514, 0.18750], -[6224, 0.59049, 0.77437, 0.28177], -[6225, 0.74702, 0.54898, 0.13046], -[6226, 0.50000, 0.82679, 0.25000], -[6227, 0.71573, 0.67736, 0.34186], -[6228, 0.76833, 0.57575, 0.22740], -[6229, 0.79624, 0.54842, 0.25227], -[6230, 0.80961, 0.58002, 0.43424], -[6231, 0.82258, 0.53770, 0.32539], -[6232, 0.50000, 0.84845, 0.33750], -[6233, 0.59558, 0.77790, 0.30913], -[6234, 0.77063, 0.60356, 0.30473], -[6235, 0.58567, 0.79421, 0.34987], -[6236, 0.75634, 0.62878, 0.32972], -[6237, 0.74501, 0.66424, 0.48223], -[6238, 0.55463, 0.68838, 0.03613], -[6239, 0.73220, 0.57936, 0.14657], -[6240, 0.85000, 0.52369, 0.50000], -[6241, 0.32679, 0.80000, 0.00000], -[6242, 0.80000, 0.32679, 0.00000], -[6243, 0.72680, 0.66360, 0.33200], -[6244, 0.69999, 0.53054, 0.02511], -[6245, 0.84641, 0.50000, 0.32500], -[6246, 0.84641, 0.17500, 0.00000], -[6247, 0.69296, 0.71886, 0.48767], -[6248, 0.55837, 0.76717, 0.18883], -[6249, 0.53850, 0.69947, 0.03314], -[6250, 0.71642, 0.58144, 0.11784], -[6251, 0.57886, 0.76066, 0.20955], -[6252, 0.06495, 0.86250, 0.00000], -[6253, 0.66558, 0.70757, 0.26640], -[6254, 0.54196, 0.81985, 0.31988], -[6255, 0.52677, 0.83694, 0.35695], -[6256, 0.79243, 0.52834, 0.19749], -[6257, 0.79942, 0.56914, 0.31113], -[6258, 0.63134, 0.77468, 0.50000], -[6259, 0.62109, 0.74617, 0.26284], -[6260, 0.83750, 0.54534, 0.50000], -[6261, 0.66249, 0.73068, 0.33866], -[6262, 0.81798, 0.56617, 0.40398], -[6263, 0.57984, 0.80884, 0.40786], -[6264, 0.64894, 0.72032, 0.25702], -[6265, 0.70883, 0.63838, 0.20139], -[6266, 0.82476, 0.50000, 0.23750], -[6267, 0.21854, 0.83750, 0.00000], -[6268, 0.67961, 0.66789, 0.19778], -[6269, 0.64351, 0.68428, 0.15776], -[6270, 0.66073, 0.66949, 0.16121], -[6271, 0.59058, 0.69671, 0.09334], -[6272, 0.73750, 0.67524, 0.50000], -[6273, 0.63184, 0.77475, 0.47979], -[6274, 0.55554, 0.67649, 0.01664], -[6275, 1.00000, 0.00000, 0.50000], -[6276, 0.00000, 1.00000, 0.50000], -[6277, 0.74320, 0.64753, 0.33150], -[6278, 0.58935, 0.80621, 0.44541], -[6279, 0.93750, 0.00000, 0.15155], -[6280, 0.00000, 0.93750, 0.15155], -[6281, 0.50000, 0.74019, 0.05000], -[6282, 0.77486, 0.63066, 0.45153], -[6283, 0.68213, 0.70388, 0.30054], -[6284, 0.63166, 0.76646, 0.38129], -[6285, 0.50000, 0.76184, 0.08750], -[6286, 0.69642, 0.67230, 0.24775], -[6287, 0.80311, 0.50000, 0.17500], -[6288, 1.00000, 0.02500, 0.50000], -[6289, 0.02500, 1.00000, 0.50000], -[6290, 1.00000, 0.00000, 0.47500], -[6291, 0.00000, 1.00000, 0.47500], -[6292, 0.69426, 0.70614, 0.35846], -[6293, 0.54330, 0.67500, 0.00000], -[6294, 0.72478, 0.52475, 0.05264], -[6295, 0.70700, 0.70755, 0.48193], -[6296, 0.73325, 0.60369, 0.18579], -[6297, 0.69756, 0.60317, 0.11211], -[6298, 0.57221, 0.72379, 0.11319], -[6299, 0.59659, 0.79984, 0.42621], -[6300, 0.52253, 0.77791, 0.14921], -[6301, 0.60736, 0.79427, 0.46100], -[6302, 0.61829, 0.77348, 0.35562], -[6303, 0.75046, 0.66010, 0.44988], -[6304, 0.60684, 0.63569, 0.02132], -[6305, 0.54252, 0.83737, 0.42215], -[6306, 0.60003, 0.74872, 0.21541], -[6307, 0.78185, 0.52521, 0.16165], -[6308, 0.72073, 0.65806, 0.27816], -[6309, 1.00000, 0.02221, 0.46458], -[6310, 0.02221, 1.00000, 0.46458], -[6311, 0.62942, 0.61092, 0.01796], -[6312, 0.83567, 0.53747, 0.37926], -[6313, 0.69552, 0.65165, 0.19427], -[6314, 0.63710, 0.67351, 0.12244], -[6315, 0.82500, 0.56699, 0.50000], -[6316, 0.74904, 0.61247, 0.24323], -[6317, 0.62791, 0.77694, 0.43435], -[6318, 0.76132, 0.51651, 0.10526], -[6319, 0.70944, 0.69841, 0.39359], -[6320, 0.54972, 0.76411, 0.15888], -[6321, 0.53399, 0.80484, 0.23636], -[6322, 0.17321, 0.85000, 0.00000], -[6323, 1.00000, 0.05000, 0.50000], -[6324, 0.05000, 1.00000, 0.50000], -[6325, 1.00000, 0.00000, 0.45000], -[6326, 0.00000, 1.00000, 0.45000], -[6327, 1.00000, 0.04330, 0.47500], -[6328, 0.04330, 1.00000, 0.47500], -[6329, 0.76115, 0.63676, 0.36696], -[6330, 0.66846, 0.74005, 0.41003], -[6331, 0.84143, 0.52474, 0.36104], -[6332, 0.64180, 0.75597, 0.36083], -[6333, 0.70956, 0.60802, 0.13994], -[6334, 0.66620, 0.59079, 0.04162], -[6335, 0.68152, 0.58577, 0.05797], -[6336, 0.55009, 0.82927, 0.38723], -[6337, 0.73674, 0.56739, 0.12804], -[6338, 0.81831, 0.51855, 0.24587], -[6339, 0.55122, 0.72579, 0.08466], -[6340, 0.58712, 0.67679, 0.05233], -[6341, 0.62954, 0.69717, 0.15239], -[6342, 0.51594, 0.81741, 0.23750], -[6343, 0.30514, 0.81250, 0.00000], -[6344, 0.81250, 0.30514, 0.00000], -[6345, 0.69084, 0.54337, 0.01961], -[6346, 0.61109, 0.76661, 0.29361], -[6347, 0.51304, 0.83355, 0.28617], -[6348, 0.66768, 0.60393, 0.06040], -[6349, 0.67254, 0.69683, 0.24316], -[6350, 0.81193, 0.53262, 0.25313], -[6351, 0.68389, 0.72703, 0.41294], -[6352, 0.68931, 0.68743, 0.26276], -[6353, 0.61574, 0.77266, 0.33281], -[6354, 0.73382, 0.68222, 0.48436], -[6355, 0.71949, 0.68495, 0.36805], -[6356, 1.00000, 0.02165, 0.43750], -[6357, 1.00000, 0.04330, 0.45000], -[6358, 0.02165, 1.00000, 0.43750], -[6359, 0.04330, 1.00000, 0.45000], -[6360, 0.58553, 0.79473, 0.32691], -[6361, 0.50000, 0.78349, 0.12500], -[6362, 0.73361, 0.63017, 0.23691], -[6363, 0.72177, 0.69519, 0.48084], -[6364, 0.63506, 0.71079, 0.18993], -[6365, 0.65216, 0.76126, 0.50000], -[6366, 0.80150, 0.59796, 0.42975], -[6367, 0.59074, 0.68771, 0.07221], -[6368, 0.56347, 0.78253, 0.22601], -[6369, 0.50000, 0.84845, 0.31250], -[6370, 0.74913, 0.65925, 0.40387], -[6371, 0.71331, 0.67207, 0.28890], -[6372, 0.61515, 0.78761, 0.42045], -[6373, 0.74898, 0.56538, 0.14721], -[6374, 0.73903, 0.67657, 0.46352], -[6375, 0.68120, 0.65167, 0.15857], -[6376, 0.61016, 0.79579, 0.50000], -[6377, 0.10825, 0.86250, 0.00000], -[6378, 1.00000, 0.07500, 0.50000], -[6379, 0.07500, 1.00000, 0.50000], -[6380, 1.00000, 0.00000, 0.42500], -[6381, 0.00000, 1.00000, 0.42500], -[6382, 1.00000, 0.06495, 0.46250], -[6383, 0.71826, 0.50883, 0.01949], -[6384, 0.06670, 1.00000, 0.46473], -[6385, 0.67321, 0.55000, 0.00000], -[6386, 0.78770, 0.61161, 0.39378], -[6387, 0.73221, 0.62118, 0.21029], -[6388, 0.64798, 0.74865, 0.33996], -[6389, 0.72373, 0.67084, 0.32049], -[6390, 0.65264, 0.75659, 0.41174], -[6391, 0.84641, 0.50000, 0.30000], -[6392, 0.84641, 0.20000, 0.00000], -[6393, 0.60583, 0.73604, 0.18717], -[6394, 0.70650, 0.67374, 0.26852], -[6395, 0.81250, 0.58864, 0.50000], -[6396, 0.71112, 0.54027, 0.04268], -[6397, 0.62078, 0.68793, 0.11514], -[6398, 0.62990, 0.60000, 0.00000], -[6399, 0.86922, 0.50000, 0.46458], -[6400, 0.86922, 0.03542, 0.00000], -[6401, 0.73781, 0.67745, 0.44063], -[6402, 0.69620, 0.58492, 0.07561], -[6403, 0.53103, 0.69847, 0.01305], -[6404, 0.69335, 0.72247, 0.43344], -[6405, 0.76478, 0.55841, 0.16745], -[6406, 0.79001, 0.59842, 0.34126], -[6407, 0.86806, 0.50000, 0.43750], -[6408, 0.86806, 0.06250, 0.00000], -[6409, 1.00000, 0.04330, 0.42500], -[6410, 0.04330, 1.00000, 0.42500], -[6411, 0.62903, 0.69058, 0.13263], -[6412, 0.82543, 0.56693, 0.43078], -[6413, 0.84722, 0.53184, 0.41635], -[6414, 0.50000, 0.87010, 0.47500], -[6415, 0.76757, 0.63922, 0.39981], -[6416, 0.75794, 0.62205, 0.28435], -[6417, 0.75981, 0.50000, 0.07500], -[6418, 0.67578, 0.63781, 0.11989], -[6419, 0.72463, 0.63173, 0.21054], -[6420, 0.56495, 0.66250, 0.00000], -[6421, 0.77375, 0.52855, 0.13940], -[6422, 1.00000, 0.02165, 0.41250], -[6423, 1.00000, 0.06495, 0.43750], -[6424, 0.02165, 1.00000, 0.41250], -[6425, 0.06495, 1.00000, 0.43750], -[6426, 0.08704, 1.00000, 0.47586], -[6427, 0.54309, 0.78751, 0.19493], -[6428, 0.57029, 0.82602, 0.47255], -[6429, 0.83908, 0.55091, 0.47227], -[6430, 0.70920, 0.62824, 0.16712], -[6431, 0.83657, 0.52545, 0.31946], -[6432, 0.74763, 0.63830, 0.29442], -[6433, 0.85808, 0.51752, 0.43142], -[6434, 1.00000, 0.08780, 0.46623], -[6435, 0.00000, 0.96964, 0.23797], -[6436, 0.96964, 0.00000, 0.23797], -[6437, 0.50000, 0.82679, 0.22500], -[6438, 0.63550, 0.75673, 0.31895], -[6439, 0.00000, 0.95000, 0.17321], -[6440, 0.95000, 0.00000, 0.17321], -[6441, 0.67922, 0.57661, 0.03571], -[6442, 0.52136, 0.82366, 0.25677], -[6443, 0.80365, 0.58781, 0.36566], -[6444, 0.50000, 0.87010, 0.45000], -[6445, 0.80616, 0.51240, 0.18829], -[6446, 0.74245, 0.66662, 0.38110], -[6447, 0.68630, 0.69954, 0.27774], -[6448, 0.70880, 0.65090, 0.21060], -[6449, 0.52643, 0.80208, 0.20102], -[6450, 0.71900, 0.52341, 0.03203], -[6451, 1.00000, 0.10000, 0.50000], -[6452, 0.10000, 1.00000, 0.50000], -[6453, 1.00000, 0.00000, 0.40000], -[6454, 0.00000, 1.00000, 0.40000], -[6455, 0.08660, 1.00000, 0.45000], -[6456, 0.78915, 0.59190, 0.30789], -[6457, 0.64851, 0.67581, 0.13568], -[6458, 0.73436, 0.67223, 0.36174], -[6459, 0.69215, 0.60252, 0.08979], -[6460, 0.59495, 0.80118, 0.37940], -[6461, 0.67386, 0.69184, 0.22131], -[6462, 0.83646, 0.55541, 0.44990], -[6463, 0.75030, 0.52783, 0.08860], -[6464, 0.60639, 0.79055, 0.36533], -[6465, 0.78146, 0.50000, 0.11250], -[6466, 0.52524, 0.71535, 0.02750], -[6467, 0.67821, 0.61519, 0.08471], -[6468, 0.75326, 0.63869, 0.31128], -[6469, 0.28349, 0.82500, 0.00000], -[6470, 0.82500, 0.28349, 0.00000], -[6471, 0.66103, 0.64352, 0.09995], -[6472, 0.86806, 0.50000, 0.41250], -[6473, 0.86806, 0.08750, 0.00000], -[6474, 0.19689, 0.85000, 0.00000], -[6475, 0.72500, 0.69689, 0.50000], -[6476, 0.61772, 0.67049, 0.07555], -[6477, 0.53631, 0.73936, 0.07902], -[6478, 0.00000, 0.97685, 0.26063], -[6479, 0.60775, 0.80119, 0.48288], -[6480, 0.58622, 0.81384, 0.42483], -[6481, 0.56449, 0.83112, 0.45233], -[6482, 1.00000, 0.08864, 0.43750], -[6483, 0.67028, 0.74225, 0.39253], -[6484, 1.00000, 0.04330, 0.40000], -[6485, 1.00000, 0.06495, 0.41250], -[6486, 0.04330, 1.00000, 0.40000], -[6487, 0.06495, 1.00000, 0.41250], -[6488, 0.54694, 0.79512, 0.21625], -[6489, 0.50000, 0.80514, 0.16250], -[6490, 0.74359, 0.63781, 0.27095], -[6491, 0.74371, 0.67298, 0.42083], -[6492, 0.58658, 0.66972, 0.03123], -[6493, 0.66166, 0.65512, 0.11866], -[6494, 0.80000, 0.61029, 0.50000], -[6495, 0.61334, 0.68636, 0.09347], -[6496, 0.75021, 0.65634, 0.36209], -[6497, 0.67686, 0.73070, 0.35659], -[6498, 0.75478, 0.53828, 0.10855], -[6499, 0.10688, 1.00000, 0.46458], -[6500, 0.50000, 0.87010, 0.42500], -[6501, 0.54860, 0.70878, 0.04235], -[6502, 1.00000, 0.11076, 0.47613], -[6503, 0.82476, 0.50000, 0.21250], -[6504, 0.72303, 0.54582, 0.06150], -[6505, 0.84999, 0.51532, 0.34193], -[6506, 0.08660, 1.00000, 0.42500], -[6507, 1.00000, 0.02165, 0.38750], -[6508, 0.02165, 1.00000, 0.38750], -[6509, 0.64127, 0.76614, 0.37737], -[6510, 0.59589, 0.77478, 0.25945], -[6511, 0.97794, 0.00000, 0.26151], -[6512, 0.68783, 0.73442, 0.47078], -[6513, 0.67339, 0.74826, 0.50000], -[6514, 0.54116, 0.83307, 0.33700], -[6515, 0.65697, 0.70392, 0.20610], -[6516, 0.58206, 0.73413, 0.13120], -[6517, 0.72682, 0.69565, 0.46042], -[6518, 0.54116, 0.84907, 0.50000], -[6519, 0.69911, 0.72345, 0.45748], -[6520, 0.57500, 0.82679, 0.50000], -[6521, 0.79320, 0.55898, 0.23056], -[6522, 0.82144, 0.53685, 0.27345], -[6523, 0.53449, 0.75294, 0.09787], -[6524, 0.76780, 0.64902, 0.43968], -[6525, 0.57308, 0.67110, 0.01449], -[6526, 0.61294, 0.72534, 0.16415], -[6527, 0.56509, 0.74655, 0.12855], -[6528, 0.63867, 0.75196, 0.29672], -[6529, 1.00000, 0.11029, 0.45000], -[6530, 0.71890, 0.56792, 0.08124], -[6531, 0.65895, 0.69090, 0.17870], -[6532, 0.63915, 0.77433, 0.41718], -[6533, 0.76310, 0.59047, 0.21019], -[6534, 0.50000, 0.84845, 0.28750], -[6535, 0.54814, 0.83412, 0.36268], -[6536, 0.81357, 0.55348, 0.28338], -[6537, 0.73797, 0.50000, 0.03036], -[6538, 0.82026, 0.55610, 0.31775], -[6539, 0.85052, 0.53856, 0.45665], -[6540, 0.53311, 0.83055, 0.29675], -[6541, 0.68066, 0.73987, 0.43136], -[6542, 0.65348, 0.60413, 0.02733], -[6543, 0.53874, 0.81713, 0.25991], -[6544, 0.10825, 1.00000, 0.43750], -[6545, 0.87500, 0.00000, 0.00000], -[6546, 0.00000, 0.87500, 0.00000], -[6547, 1.00000, 0.12500, 0.50000], -[6548, 0.12500, 1.00000, 0.50000], -[6549, 1.00000, 0.00000, 0.37500], -[6550, 0.00000, 1.00000, 0.37500], -[6551, 0.50000, 0.87500, 0.50000], -[6552, 0.87500, 0.50000, 0.50000], -[6553, 0.62783, 0.78143, 0.39592], -[6554, 0.83813, 0.55400, 0.42080], -[6555, 0.79620, 0.57034, 0.26242], -[6556, 0.64904, 0.64291, 0.07420], -[6557, 0.51449, 0.80198, 0.17116], -[6558, 0.52165, 0.86250, 0.50000], -[6559, 0.73044, 0.56885, 0.10119], -[6560, 0.86806, 0.50000, 0.38750], -[6561, 0.86806, 0.11250, 0.00000], -[6562, 0.65518, 0.62538, 0.05747], -[6563, 0.66866, 0.75367, 0.46698], -[6564, 0.84969, 0.53256, 0.39677], -[6565, 0.76792, 0.65205, 0.46245], -[6566, 0.51881, 0.75929, 0.08694], -[6567, 0.79983, 0.51264, 0.16262], -[6568, 0.71805, 0.65369, 0.22881], -[6569, 0.88750, 0.00000, 0.02165], -[6570, 0.00000, 0.88750, 0.02165], -[6571, 0.57130, 0.81063, 0.31842], -[6572, 0.68052, 0.74372, 0.48144], -[6573, 0.58660, 0.65000, 0.00000], -[6574, 0.66190, 0.58501, 0.01391], -[6575, 0.67229, 0.72165, 0.29035], -[6576, 0.59157, 0.65588, 0.01359], -[6577, 0.15155, 0.86250, 0.00000], -[6578, 1.00000, 0.06495, 0.38750], -[6579, 0.06495, 1.00000, 0.38750], -[6580, 0.69790, 0.66753, 0.20977], -[6581, 0.84641, 0.50000, 0.27500], -[6582, 0.84641, 0.22500, 0.00000], -[6583, 0.77621, 0.56261, 0.18691], -[6584, 0.50000, 0.87010, 0.40000], -[6585, 0.72613, 0.61850, 0.17246], -[6586, 0.86235, 0.52194, 0.46720], -[6587, 0.70549, 0.69246, 0.29994], -[6588, 0.78669, 0.61413, 0.35426], -[6589, 0.55456, 0.80047, 0.23724], -[6590, 0.76152, 0.57598, 0.17486], -[6591, 0.53569, 0.84671, 0.38345], -[6592, 0.80311, 0.50000, 0.15000], -[6593, 0.04330, 0.87500, 0.00000], -[6594, 0.08660, 1.00000, 0.40000], -[6595, 0.12990, 1.00000, 0.47500], -[6596, 1.00000, 0.04330, 0.37500], -[6597, 1.00000, 0.08660, 0.40000], -[6598, 0.04330, 1.00000, 0.37500], -[6599, 0.86363, 0.52100, 0.48569], -[6600, 0.63597, 0.73232, 0.22282], -[6601, 0.78303, 0.58759, 0.25656], -[6602, 0.82857, 0.57467, 0.46876], -[6603, 1.00000, 0.11029, 0.42500], -[6604, 0.76649, 0.55096, 0.14379], -[6605, 0.76416, 0.54333, 0.12717], -[6606, 0.62591, 0.79111, 0.47359], -[6607, 1.00000, 0.13078, 0.46458], -[6608, 0.74979, 0.51890, 0.06744], -[6609, 0.90000, 0.00000, 0.04330], -[6610, 0.00000, 0.90000, 0.04330], -[6611, 0.72034, 0.66309, 0.25491], -[6612, 0.51841, 0.84780, 0.32294], -[6613, 0.68239, 0.56495, 0.01618], -[6614, 0.73758, 0.59842, 0.15819], -[6615, 0.64214, 0.74608, 0.27632], -[6616, 0.51924, 0.74922, 0.06631], -[6617, 0.52966, 0.85512, 0.41377], -[6618, 0.57994, 0.71097, 0.07881], -[6619, 0.68212, 0.72116, 0.31579], -[6620, 0.12990, 1.00000, 0.45000], -[6621, 1.00000, 0.02165, 0.36250], -[6622, 0.02165, 1.00000, 0.36250], -[6623, 0.10825, 1.00000, 0.41250], -[6624, 0.68663, 0.72971, 0.37565], -[6625, 0.72626, 0.62921, 0.19005], -[6626, 0.81806, 0.59149, 0.48032], -[6627, 0.78750, 0.63194, 0.50000], -[6628, 0.65685, 0.73844, 0.29299], -[6629, 0.68691, 0.64334, 0.13410], -[6630, 0.75954, 0.62075, 0.26045], -[6631, 0.65424, 0.76619, 0.43240], -[6632, 0.65155, 0.58750, 0.00000], -[6633, 0.71267, 0.64293, 0.18599], -[6634, 0.78272, 0.63432, 0.43027], -[6635, 0.26184, 0.83750, 0.00000], -[6636, 0.62562, 0.73425, 0.20092], -[6637, 0.67390, 0.67334, 0.16464], -[6638, 0.56892, 0.72721, 0.09073], -[6639, 0.81384, 0.52731, 0.21774], -[6640, 0.74327, 0.46657, 0.00000], -[6641, 0.79555, 0.61771, 0.42430], -[6642, 0.55495, 0.84306, 0.46120], -[6643, 0.71758, 0.69504, 0.35005], -[6644, 0.79930, 0.54587, 0.21064], -[6645, 0.83169, 0.55945, 0.37392], -[6646, 0.70441, 0.54454, 0.02262], -[6647, 0.78761, 0.60653, 0.31991], -[6648, 0.43505, 0.76250, 0.00000], -[6649, 0.76250, 0.43505, 0.00000], -[6650, 0.52643, 0.84126, 0.31071], -[6651, 0.69571, 0.53542, 0.00000], -[6652, 0.57510, 0.69111, 0.03914], -[6653, 0.81914, 0.57370, 0.35626], -[6654, 0.70146, 0.63727, 0.14967], -[6655, 0.69403, 0.73432, 0.50000], -[6656, 0.52007, 0.86406, 0.43815], -[6657, 0.60621, 0.66733, 0.04374], -[6658, 0.45670, 0.75000, 0.00000], -[6659, 0.60785, 0.70467, 0.10620], -[6660, 0.72699, 0.69284, 0.38765], -[6661, 0.59343, 0.75535, 0.18620], -[6662, 0.62069, 0.74691, 0.22056], -[6663, 1.00000, 0.13194, 0.43750], -[6664, 0.59747, 0.72048, 0.11870], -[6665, 0.41340, 0.77500, 0.00000], -[6666, 0.77500, 0.41340, 0.00000], -[6667, 0.78864, 0.62551, 0.40844], -[6668, 0.82962, 0.54125, 0.29899], -[6669, 0.61082, 0.79733, 0.38633], -[6670, 0.50000, 0.76184, 0.06250], -[6671, 0.51443, 0.72500, 0.01875], -[6672, 0.64248, 0.77958, 0.46311], -[6673, 0.91250, 0.00000, 0.06495], -[6674, 0.00000, 0.91250, 0.06495], -[6675, 0.56509, 0.68884, 0.02239], -[6676, 0.58819, 0.79863, 0.30443], -[6677, 0.66816, 0.73521, 0.31271], -[6678, 0.84194, 0.53682, 0.34151], -[6679, 0.74255, 0.65486, 0.29503], -[6680, 0.86806, 0.50000, 0.36250], -[6681, 0.86806, 0.13750, 0.00000], -[6682, 0.80907, 0.54487, 0.23356], -[6683, 0.12990, 1.00000, 0.42500], -[6684, 1.00000, 0.15000, 0.50000], -[6685, 0.15000, 1.00000, 0.50000], -[6686, 1.00000, 0.00000, 0.35000], -[6687, 0.00000, 1.00000, 0.35000], -[6688, 0.84301, 0.52053, 0.29780], -[6689, 0.59721, 0.73707, 0.14989], -[6690, 0.82028, 0.57874, 0.37864], -[6691, 0.71203, 0.70680, 0.37343], -[6692, 0.82736, 0.57894, 0.44623], -[6693, 0.50000, 0.87010, 0.37500], -[6694, 0.70117, 0.64960, 0.16972], -[6695, 0.47835, 0.73750, 0.00000], -[6696, 0.79702, 0.61991, 0.44310], -[6697, 0.69362, 0.68261, 0.22464], -[6698, 0.80428, 0.58695, 0.32215], -[6699, 0.00000, 0.96458, 0.19571], -[6700, 0.96458, 0.00000, 0.19571], -[6701, 0.08660, 0.87500, 0.00000], -[6702, 0.06495, 1.00000, 0.36250], -[6703, 0.08660, 1.00000, 0.37500], -[6704, 1.00000, 0.06495, 0.36250], -[6705, 1.00000, 0.08660, 0.37500], -[6706, 0.72733, 0.67556, 0.30573], -[6707, 0.86197, 0.52171, 0.41029], -[6708, 0.74179, 0.51211, 0.04091], -[6709, 0.80733, 0.60880, 0.46935], -[6710, 0.77922, 0.60464, 0.27504], -[6711, 0.59780, 0.77252, 0.23668], -[6712, 0.84135, 0.25620, 0.00000], -[6713, 0.54239, 0.77426, 0.13963], -[6714, 0.50000, 0.82679, 0.20000], -[6715, 0.66796, 0.63246, 0.07878], -[6716, 0.39175, 0.78750, 0.00000], -[6717, 0.78750, 0.39175, 0.00000], -[6718, 0.61362, 0.72019, 0.14149], -[6719, 0.63408, 0.65795, 0.06541], -[6720, 0.53752, 0.72359, 0.04027], -[6721, 0.50000, 0.78349, 0.10000], -[6722, 0.72371, 0.61548, 0.15164], -[6723, 0.78104, 0.63281, 0.38386], -[6724, 0.62505, 0.79423, 0.45000], -[6725, 0.50000, 0.73937, 0.02315], -[6726, 0.78981, 0.57912, 0.24519], -[6727, 1.00000, 0.15359, 0.47500], -[6728, 0.61949, 0.77786, 0.31178], -[6729, 0.64431, 0.62874, 0.03752], -[6730, 0.73720, 0.68928, 0.42404], -[6731, 0.15155, 1.00000, 0.46250], -[6732, 0.10825, 1.00000, 0.38750], -[6733, 1.00000, 0.04330, 0.35000], -[6734, 1.00000, 0.10825, 0.38750], -[6735, 0.04330, 1.00000, 0.35000], -[6736, 0.62507, 0.75281, 0.24121], -[6737, 0.55624, 0.84337, 0.43899], -[6738, 0.58192, 0.82283, 0.40516], -[6739, 0.62679, 0.76314, 0.27722], -[6740, 0.54108, 0.85510, 0.46845], -[6741, 0.77476, 0.62442, 0.31339], -[6742, 0.71586, 0.69455, 0.32625], -[6743, 1.00000, 0.13194, 0.41250], -[6744, 0.79153, 0.63060, 0.46733], -[6745, 0.66655, 0.66950, 0.13563], -[6746, 0.75223, 0.60986, 0.20417], -[6747, 0.79931, 0.53031, 0.17567], -[6748, 0.69855, 0.56464, 0.03249], -[6749, 0.58903, 0.71908, 0.09828], -[6750, 0.74620, 0.66663, 0.34390], -[6751, 0.64212, 0.69632, 0.14161], -[6752, 0.72500, 0.50000, 0.00000], -[6753, 0.50000, 0.72500, 0.00000], -[6754, 0.73979, 0.65191, 0.26898], -[6755, 0.73056, 0.59987, 0.13640], -[6756, 0.53324, 0.86101, 0.48625], -[6757, 0.77104, 0.60642, 0.24771], -[6758, 0.83673, 0.50885, 0.24134], -[6759, 0.70354, 0.69327, 0.27532], -[6760, 1.00000, 0.15359, 0.45000], -[6761, 0.56437, 0.78724, 0.20355], -[6762, 0.87584, 0.50863, 0.48017], -[6763, 0.58127, 0.81388, 0.33885], -[6764, 0.72657, 0.64527, 0.21365], -[6765, 0.50000, 0.84845, 0.26250], -[6766, 0.69642, 0.71658, 0.33316], -[6767, 0.71713, 0.71493, 0.46890], -[6768, 0.70495, 0.72140, 0.40511], -[6769, 0.60825, 0.63750, 0.00000], -[6770, 0.81064, 0.60505, 0.44321], -[6771, 0.68519, 0.68396, 0.20141], -[6772, 0.57664, 0.83067, 0.43737], -[6773, 0.64428, 0.72203, 0.19990], -[6774, 0.92500, 0.00000, 0.08660], -[6775, 0.00000, 0.92500, 0.08660], -[6776, 0.54849, 0.84633, 0.40251], -[6777, 0.62914, 0.63766, 0.02648], -[6778, 0.64740, 0.77933, 0.48654], -[6779, 0.75743, 0.66968, 0.43235], -[6780, 0.86481, 0.51656, 0.39021], -[6781, 0.61460, 0.75914, 0.23022], -[6782, 0.15155, 1.00000, 0.43750], -[6783, 0.12990, 1.00000, 0.40000], -[6784, 1.00000, 0.02165, 0.33750], -[6785, 0.02165, 1.00000, 0.33750], -[6786, 0.37010, 0.80000, 0.00000], -[6787, 0.80000, 0.37010, 0.00000], -[6788, 0.63648, 0.67994, 0.10041], -[6789, 0.57290, 0.80802, 0.28538], -[6790, 0.83121, 0.55681, 0.33792], -[6791, 0.72320, 0.64560, 0.20433], -[6792, 0.76594, 0.65324, 0.38194], -[6793, 0.62747, 0.65255, 0.04409], -[6794, 0.77962, 0.63347, 0.36440], -[6795, 0.65693, 0.77069, 0.45469], -[6796, 0.51715, 0.78989, 0.13090], -[6797, 0.55529, 0.74429, 0.09341], -[6798, 0.71835, 0.71350, 0.44877], -[6799, 0.67979, 0.71044, 0.25316], -[6800, 0.77500, 0.65359, 0.50000], -[6801, 0.52811, 0.85124, 0.34401], -[6802, 0.74238, 0.54223, 0.07256], -[6803, 0.77190, 0.65710, 0.48449], -[6804, 0.82476, 0.50000, 0.18750], -[6805, 0.64807, 0.77274, 0.39608], -[6806, 0.67181, 0.74827, 0.37048], -[6807, 0.81821, 0.57454, 0.33129], -[6808, 0.83757, 0.51946, 0.26168], -[6809, 0.73239, 0.65355, 0.24568], -[6810, 0.74969, 0.56088, 0.11035], -[6811, 0.56350, 0.82968, 0.34957], -[6812, 0.77015, 0.64181, 0.34666], -[6813, 0.75855, 0.67240, 0.46750], -[6814, 0.54435, 0.85387, 0.44343], -[6815, 0.52452, 0.86138, 0.39228], -[6816, 0.84641, 0.50000, 0.25000], -[6817, 0.70986, 0.62738, 0.13740], -[6818, 0.66406, 0.61359, 0.03988], -[6819, 0.68960, 0.60522, 0.06713], -[6820, 1.00000, 0.15359, 0.42500], -[6821, 0.53348, 0.80118, 0.17919], -[6822, 0.55404, 0.82735, 0.30485], -[6823, 0.50000, 0.87010, 0.35000], -[6824, 0.77503, 0.53103, 0.11660], -[6825, 0.50000, 0.80514, 0.13750], -[6826, 0.68324, 0.66321, 0.14925], -[6827, 0.52165, 0.71250, 0.00000], -[6828, 0.71219, 0.66905, 0.22624], -[6829, 0.75981, 0.50000, 0.05000], -[6830, 0.86806, 0.50000, 0.33750], -[6831, 0.86806, 0.16250, 0.00000], -[6832, 0.80313, 0.61336, 0.40663], -[6833, 1.00000, 0.08660, 0.35000], -[6834, 0.08660, 1.00000, 0.35000], -[6835, 0.51821, 0.78077, 0.11029], -[6836, 0.76777, 0.51491, 0.08116], -[6837, 1.00000, 0.13194, 0.38750], -[6838, 0.56830, 0.83132, 0.37337], -[6839, 0.71455, 0.72081, 0.50000], -[6840, 0.24019, 0.85000, 0.00000], -[6841, 0.73500, 0.69985, 0.48448], -[6842, 0.61768, 0.76804, 0.25672], -[6843, 0.17321, 1.00000, 0.47500], -[6844, 0.15155, 1.00000, 0.41250], -[6845, 1.00000, 0.17500, 0.50000], -[6846, 1.00000, 0.06495, 0.33750], -[6847, 0.06495, 1.00000, 0.33750], -[6848, 0.10825, 1.00000, 0.36250], -[6849, 0.17500, 1.00000, 0.50000], -[6850, 1.00000, 0.00000, 0.32500], -[6851, 0.00000, 1.00000, 0.32500], -[6852, 1.00000, 0.10825, 0.36250], -[6853, 0.52339, 0.74146, 0.04510], -[6854, 0.78146, 0.50000, 0.08750], -[6855, 0.55162, 0.76372, 0.12143], -[6856, 0.66817, 0.74938, 0.34873], -[6857, 0.00000, 0.97500, 0.21651], -[6858, 0.97500, 0.00000, 0.21651], -[6859, 0.72020, 0.60399, 0.11592], -[6860, 0.78083, 0.64368, 0.41605], -[6861, 0.63399, 0.77633, 0.33740], -[6862, 0.66356, 0.72325, 0.23916], -[6863, 0.82515, 0.58734, 0.42497], -[6864, 0.79545, 0.54914, 0.18824], -[6865, 0.34845, 0.81250, 0.00000], -[6866, 0.81250, 0.34845, 0.00000], -[6867, 0.67106, 0.76039, 0.44396], -[6868, 0.64754, 0.74086, 0.24772], -[6869, 0.65848, 0.66006, 0.09658], -[6870, 1.00000, 0.17524, 0.46250], -[6871, 0.61207, 0.80891, 0.44366], -[6872, 0.61162, 0.65779, 0.02520], -[6873, 0.71420, 0.57281, 0.05953], -[6874, 0.59179, 0.79233, 0.26696], -[6875, 0.75496, 0.58686, 0.15649], -[6876, 0.93750, 0.00000, 0.10825], -[6877, 0.00000, 0.93750, 0.10825], -[6878, 0.78769, 0.62099, 0.33774], -[6879, 0.64823, 0.66448, 0.08681], -[6880, 0.12990, 0.87500, 0.00000], -[6881, 0.17321, 1.00000, 0.45000], -[6882, 0.04330, 1.00000, 0.32500], -[6883, 0.12990, 1.00000, 0.37500], -[6884, 1.00000, 0.04330, 0.32500], -[6885, 0.56520, 0.84077, 0.42128], -[6886, 0.52272, 0.87093, 0.47040], -[6887, 0.56745, 0.72114, 0.06327], -[6888, 0.78615, 0.54256, 0.15302], -[6889, 0.69152, 0.63797, 0.11580], -[6890, 0.71986, 0.59366, 0.09715], -[6891, 0.80824, 0.58029, 0.29278], -[6892, 0.57128, 0.80769, 0.26716], -[6893, 0.65641, 0.72422, 0.22146], -[6894, 0.77529, 0.59802, 0.22737], -[6895, 0.72318, 0.71052, 0.42677], -[6896, 0.60730, 0.78914, 0.29593], -[6897, 0.65893, 0.77361, 0.47645], -[6898, 0.60061, 0.81914, 0.46067], -[6899, 0.56720, 0.76446, 0.14326], -[6900, 0.74373, 0.66770, 0.31427], -[6901, 0.58673, 0.75615, 0.15720], -[6902, 0.61168, 0.78031, 0.27519], -[6903, 1.00000, 0.15359, 0.40000], -[6904, 0.64923, 0.70596, 0.16270], -[6905, 0.69441, 0.62537, 0.09946], -[6906, 0.81183, 0.59211, 0.34463], -[6907, 0.67321, 0.57500, 0.00000], -[6908, 0.76252, 0.59618, 0.18857], -[6909, 0.85981, 0.54241, 0.47730], -[6910, 0.83392, 0.57447, 0.40673], -[6911, 0.79586, 0.62061, 0.37429], -[6912, 0.60661, 0.79587, 0.31787], -[6913, 1.00000, 0.17524, 0.43750], -[6914, 0.85772, 0.53248, 0.37525], -[6915, 0.69295, 0.74084, 0.42393], -[6916, 0.53621, 0.74443, 0.06054], -[6917, 0.58899, 0.82120, 0.38360], -[6918, 0.58269, 0.79467, 0.24734], -[6919, 0.75219, 0.68293, 0.44811], -[6920, 0.57500, 0.83906, 0.48406], -[6921, 0.68498, 0.73396, 0.33536], -[6922, 0.54330, 0.70000, 0.00000], -[6923, 0.75955, 0.56487, 0.12690], -[6924, 0.84658, 0.54712, 0.36151], -[6925, 0.73891, 0.56432, 0.08673], -[6926, 0.79166, 0.56618, 0.20315], -[6927, 0.72811, 0.70464, 0.40541], -[6928, 0.80311, 0.50000, 0.12500], -[6929, 0.17321, 1.00000, 0.42500], -[6930, 0.15155, 1.00000, 0.38750], -[6931, 1.00000, 0.02165, 0.31250], -[6932, 0.02165, 1.00000, 0.31250], -[6933, 0.62834, 0.71281, 0.13570], -[6934, 0.59407, 0.81401, 0.35792], -[6935, 0.61750, 0.79410, 0.34555], -[6936, 0.67319, 0.75927, 0.42162], -[6937, 0.74122, 0.69060, 0.40232], -[6938, 0.85328, 0.55102, 0.43508], -[6939, 0.68188, 0.63839, 0.09569], -[6940, 0.87342, 0.51710, 0.42407], -[6941, 0.84041, 0.54538, 0.32026], -[6942, 0.79642, 0.52476, 0.14449], -[6943, 0.80606, 0.62139, 0.48521], -[6944, 0.73948, 0.64118, 0.22015], -[6945, 0.56250, 0.84845, 0.50000], -[6946, 0.78725, 0.55389, 0.16876], -[6947, 0.57863, 0.77745, 0.18844], -[6948, 1.00000, 0.13194, 0.36250], -[6949, 0.55358, 0.82702, 0.28538], -[6950, 0.60759, 0.68626, 0.05668], -[6951, 0.63821, 0.72422, 0.17575], -[6952, 0.58937, 0.69964, 0.05263], -[6953, 0.63486, 0.78697, 0.37902], -[6954, 0.60246, 0.80502, 0.33852], -[6955, 0.53984, 0.78770, 0.14605], -[6956, 0.54658, 0.82064, 0.24477], -[6957, 0.60286, 0.81493, 0.40108], -[6958, 0.60558, 0.74857, 0.16792], -[6959, 0.76250, 0.67524, 0.50000], -[6960, 0.59708, 0.76804, 0.19837], -[6961, 0.62990, 0.62500, 0.00000], -[6962, 0.32679, 0.82500, 0.00000], -[6963, 0.82500, 0.32679, 0.00000], -[6964, 0.62719, 0.79942, 0.42924], -[6965, 0.79834, 0.59101, 0.27419], -[6966, 0.52039, 0.80283, 0.15027], -[6967, 0.50000, 0.87010, 0.32500], -[6968, 0.76596, 0.64963, 0.32925], -[6969, 0.73517, 0.68605, 0.33624], -[6970, 0.77985, 0.63267, 0.32811], -[6971, 0.73411, 0.67391, 0.28798], -[6972, 0.02165, 0.88750, 0.00000], -[6973, 0.08660, 1.00000, 0.32500], -[6974, 1.00000, 0.08660, 0.32500], -[6975, 0.10825, 1.00000, 0.33750], -[6976, 0.70700, 0.62693, 0.11890], -[6977, 0.70160, 0.71375, 0.30903], -[6978, 0.67129, 0.75984, 0.39874], -[6979, 0.78461, 0.58316, 0.21267], -[6980, 0.75331, 0.68593, 0.48200], -[6981, 0.85342, 0.51184, 0.28086], -[6982, 0.81819, 0.60008, 0.40605], -[6983, 1.00000, 0.17524, 0.41250], -[6984, 0.66750, 0.73569, 0.27283], -[6985, 0.75065, 0.58452, 0.13484], -[6986, 0.71857, 0.58179, 0.07143], -[6987, 0.75183, 0.62968, 0.22294], -[6988, 0.59372, 0.82806, 0.47843], -[6989, 0.86806, 0.50000, 0.31250], -[6990, 0.86806, 0.18750, 0.00000], -[6991, 0.54864, 0.84472, 0.34445], -[6992, 0.50000, 0.84845, 0.23750], -[6993, 0.70085, 0.72563, 0.35490], -[6994, 0.68325, 0.65721, 0.12572], -[6995, 0.73744, 0.69100, 0.36698], -[6996, 0.71651, 0.52500, 0.00000], -[6997, 0.57516, 0.77146, 0.16363], -[6998, 0.62176, 0.67290, 0.05307], -[6999, 0.78790, 0.64620, 0.47213], -[7000, 0.50000, 0.82679, 0.17500], -[7001, 1.00000, 0.15359, 0.37500], -[7002, 1.00000, 0.06495, 0.31250], -[7003, 0.06495, 1.00000, 0.31250], -[7004, 0.12990, 1.00000, 0.35000], -[7005, 0.62539, 0.70987, 0.12008], -[7006, 1.00000, 0.19689, 0.47500], -[7007, 0.64833, 0.64648, 0.05153], -[7008, 0.95000, 0.00000, 0.12990], -[7009, 0.00000, 0.95000, 0.12990], -[7010, 0.58519, 0.73812, 0.10984], -[7011, 0.52107, 0.85086, 0.29005], -[7012, 0.19571, 1.00000, 0.46458], -[7013, 0.54171, 0.71630, 0.01695], -[7014, 0.87500, 0.52369, 0.50000], -[7015, 0.74954, 0.61127, 0.17682], -[7016, 0.52630, 0.82361, 0.20913], -[7017, 0.17321, 1.00000, 0.40000], -[7018, 1.00000, 0.20000, 0.50000], -[7019, 0.20000, 1.00000, 0.50000], -[7020, 1.00000, 0.00000, 0.30000], -[7021, 0.00000, 1.00000, 0.30000], -[7022, 0.74042, 0.62804, 0.18779], -[7023, 0.77423, 0.62762, 0.28353], -[7024, 0.65813, 0.75541, 0.30841], -[7025, 0.59961, 0.82524, 0.50000], -[7026, 0.87199, 0.52625, 0.44280], -[7027, 0.70082, 0.67334, 0.18944], -[7028, 0.88912, 0.50000, 0.47685], -[7029, 0.88912, 0.02315, 0.00000], -[7030, 0.69649, 0.73768, 0.39102], -[7031, 0.65713, 0.71337, 0.18295], -[7032, 0.63480, 0.79891, 0.50000], -[7033, 1.00000, 0.19689, 0.45000], -[7034, 0.56115, 0.79036, 0.18103], -[7035, 0.86250, 0.54534, 0.50000], -[7036, 0.70896, 0.73367, 0.47627], -[7037, 0.84283, 0.53193, 0.28023], -[7038, 0.70555, 0.68919, 0.23762], -[7039, 0.21854, 0.86250, 0.00000], -[7040, 0.65665, 0.67773, 0.11116], -[7041, 0.73652, 0.58913, 0.10989], -[7042, 0.84885, 0.55422, 0.38162], -[7043, 0.66414, 0.69237, 0.15173], -[7044, 0.56495, 0.68750, 0.00000], -[7045, 0.06495, 0.88750, 0.00000], -[7046, 0.19486, 1.00000, 0.43750], -[7047, 0.15155, 1.00000, 0.36250], -[7048, 1.00000, 0.04330, 0.30000], -[7049, 0.04330, 1.00000, 0.30000], -[7050, 0.81274, 0.57354, 0.27082], -[7051, 0.84641, 0.50000, 0.22500], -[7052, 0.62508, 0.73868, 0.17493], -[7053, 0.78961, 0.61496, 0.29864], -[7054, 0.70379, 0.58221, 0.04399], -[7055, 0.54773, 0.84106, 0.31317], -[7056, 0.71133, 0.69074, 0.25660], -[7057, 0.72508, 0.68064, 0.26856], -[7058, 0.67872, 0.65200, 0.10381], -[7059, 0.68481, 0.68649, 0.17979], -[7060, 1.00000, 0.11029, 0.32500], -[7061, 0.52128, 0.82045, 0.18695], -[7062, 0.64257, 0.69503, 0.11660], -[7063, 0.81361, 0.53687, 0.19509], -[7064, 0.72194, 0.68967, 0.28476], -[7065, 0.57030, 0.82501, 0.30672], -[7066, 1.00000, 0.17524, 0.38750], -[7067, 0.73804, 0.70386, 0.44215], -[7068, 0.56006, 0.70323, 0.01476], -[7069, 0.76822, 0.57345, 0.14676], -[7070, 1.00000, 0.13194, 0.33750], -[7071, 0.75665, 0.54989, 0.08883], -[7072, 0.85000, 0.56699, 0.50000], -[7073, 0.63903, 0.75970, 0.25809], -[7074, 0.88971, 0.50000, 0.45000], -[7075, 0.88971, 0.05000, 0.00000], -[7076, 0.71008, 0.72510, 0.38124], -[7077, 0.82476, 0.50000, 0.16250], -[7078, 0.69491, 0.74764, 0.45130], -[7079, 0.64711, 0.78854, 0.43901], -[7080, 1.00000, 0.19689, 0.42500], -[7081, 0.59806, 0.82649, 0.43907], -[7082, 0.50000, 0.78349, 0.07500], -[7083, 0.30514, 0.83750, 0.00000], -[7084, 0.83750, 0.30514, 0.00000], -[7085, 0.69527, 0.67176, 0.16854], -[7086, 0.84900, 0.56854, 0.47659], -[7087, 0.60487, 0.77448, 0.21911], -[7088, 0.71136, 0.61308, 0.09664], -[7089, 0.56247, 0.83545, 0.32532], -[7090, 0.57522, 0.83756, 0.38733], -[7091, 0.65347, 0.78617, 0.50000], -[7092, 0.71437, 0.71538, 0.34818], -[7093, 0.55891, 0.74269, 0.07430], -[7094, 0.72062, 0.67872, 0.24456], -[7095, 0.77189, 0.53350, 0.09399], -[7096, 0.68932, 0.74951, 0.40852], -[7097, 0.51070, 0.88567, 0.48684], -[7098, 0.82968, 0.59629, 0.46110], -[7099, 0.17321, 0.87500, 0.00000], -[7100, 0.19486, 1.00000, 0.41250], -[7101, 0.17321, 1.00000, 0.37500], -[7102, 1.00000, 0.02165, 0.28750], -[7103, 0.02165, 1.00000, 0.28750], -[7104, 0.54113, 0.84989, 0.32511], -[7105, 0.67587, 0.70308, 0.19236], -[7106, 0.76570, 0.62643, 0.24093], -[7107, 0.53836, 0.75858, 0.07492], -[7108, 1.00000, 0.15359, 0.35000], -[7109, 0.66773, 0.65298, 0.08296], -[7110, 0.77115, 0.66997, 0.44846], -[7111, 0.83158, 0.58505, 0.38860], -[7112, 0.64102, 0.79211, 0.41118], -[7113, 0.75445, 0.64219, 0.24575], -[7114, 0.81083, 0.56770, 0.24178], -[7115, 0.61169, 0.80910, 0.36732], -[7116, 0.69990, 0.70752, 0.26339], -[7117, 0.82064, 0.57919, 0.30627], -[7118, 0.55667, 0.85802, 0.47975], -[7119, 0.66402, 0.76874, 0.37911], -[7120, 0.71179, 0.59966, 0.07541], -[7121, 0.59865, 0.68742, 0.03555], -[7122, 0.67796, 0.62377, 0.05507], -[7123, 0.52089, 0.87594, 0.40966], -[7124, 0.54951, 0.81713, 0.22227], -[7125, 0.10825, 1.00000, 0.31250], -[7126, 0.74114, 0.53914, 0.04508], -[7127, 0.86148, 0.53209, 0.35260], -[7128, 0.50000, 0.87010, 0.30000], -[7129, 0.67900, 0.76535, 0.48376], -[7130, 0.88971, 0.50000, 0.42500], -[7131, 0.88971, 0.07500, 0.00000], -[7132, 0.69791, 0.70248, 0.24179], -[7133, 0.76422, 0.67527, 0.41453], -[7134, 0.53274, 0.83098, 0.22964], -[7135, 0.58703, 0.83731, 0.45759], -[7136, 0.21651, 1.00000, 0.47500], -[7137, 0.12990, 1.00000, 0.32500], -[7138, 0.08660, 1.00000, 0.30000], -[7139, 0.70159, 0.74428, 0.46099], -[7140, 0.68898, 0.60536, 0.04551], -[7141, 0.51173, 0.76124, 0.04571], -[7142, 0.85994, 0.54811, 0.41153], -[7143, 0.84384, 0.57527, 0.43066], -[7144, 0.00000, 0.96250, 0.15155], -[7145, 0.96250, 0.00000, 0.15155], -[7146, 0.52189, 0.87120, 0.37170], -[7147, 0.58688, 0.78623, 0.20799], -[7148, 0.56799, 0.80391, 0.21893], -[7149, 0.83750, 0.58864, 0.50000], -[7150, 0.73870, 0.51319, 0.01111], -[7151, 0.75000, 0.69689, 0.50000], -[7152, 0.62225, 0.81219, 0.46385], -[7153, 0.55836, 0.85006, 0.38211], -[7154, 0.72096, 0.66274, 0.20099], -[7155, 0.50000, 0.80514, 0.11250], -[7156, 0.75999, 0.67775, 0.39255], -[7157, 0.71753, 0.64289, 0.15292], -[7158, 0.77006, 0.61636, 0.22479], -[7159, 0.86806, 0.50000, 0.28750], -[7160, 0.86806, 0.21250, 0.00000], -[7161, 0.79875, 0.58162, 0.23081], -[7162, 1.00000, 0.19689, 0.40000], -[7163, 0.50000, 0.89312, 0.46458], -[7164, 0.61298, 0.70726, 0.08397], -[7165, 0.50000, 0.89175, 0.43750], -[7166, 0.59383, 0.81487, 0.31965], -[7167, 0.82397, 0.52487, 0.19214], -[7168, 0.69486, 0.56250, 0.00000], -[7169, 0.74975, 0.69686, 0.46062], -[7170, 0.62836, 0.78150, 0.29092], -[7171, 0.77548, 0.66173, 0.39980], -[7172, 0.73129, 0.58455, 0.08424], -[7173, 0.10825, 0.88750, 0.00000], -[7174, 0.21651, 1.00000, 0.45000], -[7175, 0.15155, 1.00000, 0.33750], -[7176, 0.06495, 1.00000, 0.28750], -[7177, 1.00000, 0.06495, 0.28750], -[7178, 0.71762, 0.53975, 0.00688], -[7179, 1.00000, 0.21962, 0.46458], -[7180, 0.62946, 0.70176, 0.09899], -[7181, 0.60468, 0.70562, 0.06868], -[7182, 0.70946, 0.70888, 0.29080], -[7183, 1.00000, 0.17524, 0.36250], -[7184, 0.77992, 0.57565, 0.16838], -[7185, 0.78182, 0.58474, 0.18938], -[7186, 0.65155, 0.61250, 0.00000], -[7187, 0.58660, 0.67500, 0.00000], -[7188, 0.66166, 0.77758, 0.41395], -[7189, 0.55440, 0.80722, 0.19821], -[7190, 0.71352, 0.73277, 0.43658], -[7191, 0.67663, 0.60407, 0.02319], -[7192, 0.78745, 0.65393, 0.45051], -[7193, 0.66103, 0.76599, 0.33719], -[7194, 0.84350, 0.57076, 0.38598], -[7195, 0.79155, 0.51860, 0.10654], -[7196, 0.70298, 0.64743, 0.12991], -[7197, 0.61637, 0.75643, 0.18660], -[7198, 0.79593, 0.52236, 0.12053], -[7199, 0.55522, 0.85820, 0.42457], -[7200, 0.65235, 0.74321, 0.23063], -[7201, 0.64855, 0.76817, 0.30033], -[7202, 0.72664, 0.62087, 0.12969], -[7203, 0.19486, 1.00000, 0.38750], -[7204, 1.00000, 0.22500, 0.50000], -[7205, 0.22500, 1.00000, 0.50000], -[7206, 1.00000, 0.00000, 0.27500], -[7207, 0.00000, 1.00000, 0.27500], -[7208, 0.62691, 0.80334, 0.38898], -[7209, 0.51917, 0.86295, 0.30900], -[7210, 0.59348, 0.80668, 0.28145], -[7211, 0.56961, 0.71489, 0.03602], -[7212, 0.64616, 0.79561, 0.48036], -[7213, 0.53221, 0.84805, 0.27982], -[7214, 0.80932, 0.56390, 0.22072], -[7215, 0.71861, 0.70378, 0.30177], -[7216, 0.75376, 0.65870, 0.27843], -[7217, 0.72847, 0.64676, 0.18032], -[7218, 0.75953, 0.67613, 0.36907], -[7219, 0.73574, 0.52956, 0.02100], -[7220, 0.72364, 0.71711, 0.38456], -[7221, 0.50000, 0.76203, 0.03036], -[7222, 0.85865, 0.53280, 0.32629], -[7223, 0.76695, 0.63964, 0.26759], -[7224, 0.86226, 0.51785, 0.30035], -[7225, 0.78515, 0.54635, 0.13040], -[7226, 0.61991, 0.73930, 0.15256], -[7227, 0.62722, 0.79272, 0.32749], -[7228, 0.88971, 0.50000, 0.40000], -[7229, 0.88971, 0.10000, 0.00000], -[7230, 0.77870, 0.62315, 0.26145], -[7231, 0.82557, 0.55836, 0.25857], -[7232, 1.00000, 0.21854, 0.43750], -[7233, 0.88018, 0.51711, 0.40173], -[7234, 0.69869, 0.62211, 0.07975], -[7235, 0.70847, 0.59517, 0.05760], -[7236, 0.68700, 0.72558, 0.26883], -[7237, 0.78146, 0.50000, 0.06250], -[7238, 0.53833, 0.87164, 0.44971], -[7239, 1.00000, 0.11029, 0.30000], -[7240, 0.58919, 0.68545, 0.01504], -[7241, 0.80705, 0.61034, 0.33151], -[7242, 0.67408, 0.77322, 0.50000], -[7243, 0.53799, 0.78662, 0.12040], -[7244, 0.81798, 0.60750, 0.38061], -[7245, 0.21651, 1.00000, 0.42500], -[7246, 0.17321, 1.00000, 0.35000], -[7247, 0.04330, 1.00000, 0.27500], -[7248, 1.00000, 0.04330, 0.27500], -[7249, 0.50000, 0.84845, 0.21250], -[7250, 0.65243, 0.77976, 0.36263], -[7251, 1.00000, 0.13194, 0.31250], -[7252, 0.73050, 0.72027, 0.48203], -[7253, 0.81113, 0.61238, 0.35924], -[7254, 0.66852, 0.64350, 0.06206], -[7255, 0.28349, 0.85000, 0.00000], -[7256, 0.85000, 0.28349, 0.00000], -[7257, 0.50000, 0.89175, 0.41250], -[7258, 0.74129, 0.64409, 0.20250], -[7259, 0.57121, 0.85080, 0.44741], -[7260, 0.83066, 0.56621, 0.29411], -[7261, 1.00000, 0.08864, 0.28750], -[7262, 0.82500, 0.61029, 0.50000], -[7263, 0.88383, 0.51990, 0.45934], -[7264, 0.70273, 0.66085, 0.14976], -[7265, 0.81644, 0.61851, 0.43560], -[7266, 0.62933, 0.69225, 0.07809], -[7267, 0.79148, 0.59966, 0.24037], -[7268, 0.64844, 0.63118, 0.01550], -[7269, 0.69662, 0.58079, 0.01927], -[7270, 0.88724, 0.51252, 0.43786], -[7271, 0.82537, 0.59476, 0.36299], -[7272, 0.67542, 0.75351, 0.32734], -[7273, 0.75467, 0.69253, 0.43135], -[7274, 0.54435, 0.86028, 0.36708], -[7275, 0.83510, 0.53431, 0.23295], -[7276, 1.00000, 0.15359, 0.32500], -[7277, 0.71733, 0.73334, 0.45663], -[7278, 0.52110, 0.77205, 0.06799], -[7279, 0.70976, 0.68230, 0.20851], -[7280, 0.76445, 0.53587, 0.07239], -[7281, 0.19689, 0.87500, 0.00000], -[7282, 1.00000, 0.19689, 0.37500], -[7283, 0.76262, 0.65861, 0.30220], -[7284, 0.80861, 0.53327, 0.15892], -[7285, 0.51920, 0.84682, 0.23929], -[7286, 0.58067, 0.69929, 0.02195], -[7287, 0.83608, 0.55381, 0.27848], -[7288, 0.69295, 0.64113, 0.09553], -[7289, 0.82192, 0.54575, 0.21457], -[7290, 0.78385, 0.65257, 0.37896], -[7291, 0.62658, 0.80865, 0.40825], -[7292, 0.80311, 0.50000, 0.10000], -[7293, 0.59775, 0.82817, 0.39120], -[7294, 0.84351, 0.56505, 0.34409], -[7295, 0.70706, 0.56367, 0.01268], -[7296, 0.64094, 0.80181, 0.45994], -[7297, 0.72964, 0.66948, 0.22660], -[7298, 0.72019, 0.72086, 0.36961], -[7299, 0.73076, 0.56553, 0.05104], -[7300, 0.82331, 0.51833, 0.17001], -[7301, 1.00000, 0.21854, 0.41250], -[7302, 0.53467, 0.73553, 0.02189], -[7303, 0.81533, 0.51522, 0.14598], -[7304, 0.80782, 0.60562, 0.30905], -[7305, 0.76063, 0.50000, 0.02315], -[7306, 0.84099, 0.59026, 0.48016], -[7307, 0.74486, 0.66909, 0.26853], -[7308, 0.77482, 0.66073, 0.36154], -[7309, 0.50000, 0.82679, 0.15000], -[7310, 0.68760, 0.75513, 0.38519], -[7311, 0.68908, 0.75952, 0.43295], -[7312, 0.76781, 0.64941, 0.28797], -[7313, 0.87332, 0.54031, 0.45884], -[7314, 0.84641, 0.50000, 0.20000], -[7315, 0.58341, 0.83398, 0.35629], -[7316, 0.75060, 0.57705, 0.09967], -[7317, 0.87980, 0.53122, 0.47891], -[7318, 0.68422, 0.71145, 0.21299], -[7319, 0.64123, 0.72294, 0.14948], -[7320, 0.58214, 0.82213, 0.29492], -[7321, 0.19486, 1.00000, 0.36250], -[7322, 0.21651, 1.00000, 0.40000], -[7323, 0.12990, 1.00000, 0.30000], -[7324, 0.10825, 1.00000, 0.28750], -[7325, 0.02165, 1.00000, 0.26250], -[7326, 0.68410, 0.74303, 0.30771], -[7327, 1.00000, 0.17524, 0.33750], -[7328, 0.53744, 0.87334, 0.42535], -[7329, 0.61063, 0.74070, 0.13161], -[7330, 0.88971, 0.50000, 0.37500], -[7331, 0.88971, 0.12500, 0.00000], -[7332, 0.57874, 0.83152, 0.32438], -[7333, 0.51816, 0.85562, 0.26171], -[7334, 0.00000, 0.97500, 0.17321], -[7335, 0.97500, 0.00000, 0.17321], -[7336, 0.55760, 0.86300, 0.45797], -[7337, 0.69211, 0.74757, 0.35979], -[7338, 0.23797, 1.00000, 0.46964], -[7339, 0.50000, 0.87010, 0.27500], -[7340, 0.73559, 0.57356, 0.06682], -[7341, 0.80788, 0.60000, 0.28775], -[7342, 0.73722, 0.71609, 0.46156], -[7343, 0.80413, 0.63972, 0.45653], -[7344, 0.67915, 0.74355, 0.29099], -[7345, 1.00000, 0.23937, 0.47685], -[7346, 0.50000, 0.89175, 0.38750], -[7347, 0.61910, 0.76653, 0.20468], -[7348, 0.55256, 0.84228, 0.29180], -[7349, 0.15155, 1.00000, 0.31250], -[7350, 0.08660, 1.00000, 0.27500], -[7351, 0.84719, 0.58190, 0.45743], -[7352, 0.77104, 0.51863, 0.05873], -[7353, 0.64896, 0.78975, 0.38373], -[7354, 0.59620, 0.77200, 0.17281], -[7355, 0.80722, 0.63756, 0.47907], -[7356, 0.66716, 0.72380, 0.20078], -[7357, 0.75746, 0.51998, 0.03682], -[7358, 0.51443, 0.75000, 0.01875], -[7359, 0.60564, 0.79362, 0.25063], -[7360, 0.76745, 0.61618, 0.19971], -[7361, 0.60825, 0.66250, 0.00000], -[7362, 0.84064, 0.54082, 0.25561], -[7363, 0.69219, 0.76067, 0.46489], -[7364, 0.53294, 0.77738, 0.08693], -[7365, 0.65653, 0.66279, 0.06547], -[7366, 0.45670, 0.77500, 0.00000], -[7367, 0.79512, 0.60733, 0.25869], -[7368, 0.59941, 0.83244, 0.41553], -[7369, 0.43505, 0.78750, 0.00000], -[7370, 0.78750, 0.43505, 0.00000], -[7371, 0.81250, 0.63194, 0.50000], -[7372, 0.54943, 0.77258, 0.09906], -[7373, 0.84880, 0.52330, 0.24452], -[7374, 0.55000, 0.87010, 0.50000], -[7375, 0.66574, 0.63649, 0.04037], -[7376, 0.80550, 0.63710, 0.42953], -[7377, 0.87109, 0.51841, 0.32037], -[7378, 0.56285, 0.85058, 0.36000], -[7379, 0.86806, 0.50000, 0.26250], -[7380, 0.86806, 0.23750, 0.00000], -[7381, 0.51310, 0.81265, 0.13084], -[7382, 0.90000, 0.50000, 0.50000], -[7383, 0.90000, 0.00000, 0.00000], -[7384, 0.00000, 0.90000, 0.00000], -[7385, 0.50000, 0.90000, 0.50000], -[7386, 1.00000, 0.24019, 0.45000], -[7387, 0.73750, 0.71854, 0.50000], -[7388, 0.77449, 0.45867, 0.00000], -[7389, 0.47835, 0.76250, 0.00000], -[7390, 0.82599, 0.61027, 0.42566], -[7391, 0.71756, 0.71851, 0.32939], -[7392, 0.64113, 0.67972, 0.06732], -[7393, 0.75345, 0.65893, 0.25804], -[7394, 1.00000, 0.21854, 0.38750], -[7395, 0.72767, 0.55316, 0.02563], -[7396, 0.69583, 0.75923, 0.50000], -[7397, 0.15155, 0.88750, 0.00000], -[7398, 0.23816, 1.00000, 0.43750], -[7399, 0.17321, 1.00000, 0.32500], -[7400, 0.06495, 1.00000, 0.26250], -[7401, 0.55918, 0.79323, 0.15539], -[7402, 0.66338, 0.75681, 0.28085], -[7403, 0.52755, 0.82021, 0.16859], -[7404, 0.41340, 0.80000, 0.00000], -[7405, 0.80000, 0.41340, 0.00000], -[7406, 0.73782, 0.63382, 0.16108], -[7407, 0.64926, 0.76791, 0.27694], -[7408, 0.78321, 0.66828, 0.46793], -[7409, 0.67740, 0.77518, 0.46307], -[7410, 0.78040, 0.60480, 0.20618], -[7411, 0.63705, 0.80934, 0.48087], -[7412, 1.00000, 0.19689, 0.35000], -[7413, 0.62198, 0.81805, 0.42697], -[7414, 0.91250, 0.00000, 0.02165], -[7415, 0.00000, 0.91250, 0.02165], -[7416, 0.64165, 0.78389, 0.31196], -[7417, 0.82476, 0.50000, 0.13750], -[7418, 0.79748, 0.56968, 0.18192], -[7419, 0.81562, 0.62375, 0.41382], -[7420, 0.60946, 0.82242, 0.38159], -[7421, 0.80060, 0.63238, 0.35515], -[7422, 0.66485, 0.62336, 0.01911], -[7423, 0.04330, 0.90000, 0.00000], -[7424, 0.73441, 0.69847, 0.31351], -[7425, 0.83214, 0.60763, 0.47914], -[7426, 0.54232, 0.87100, 0.40313], -[7427, 0.87370, 0.53667, 0.39611], -[7428, 0.63622, 0.65698, 0.02480], -[7429, 0.61033, 0.67624, 0.01790], -[7430, 0.26184, 0.86250, 0.00000], -[7431, 0.67839, 0.67328, 0.11407], -[7432, 0.69063, 0.74911, 0.34397], -[7433, 0.86121, 0.53330, 0.30925], -[7434, 0.21651, 1.00000, 0.37500], -[7435, 0.75000, 0.50000, 0.00000], -[7436, 1.00000, 0.25000, 0.50000], -[7437, 0.25000, 1.00000, 0.50000], -[7438, 1.00000, 0.00000, 0.25000], -[7439, 0.00000, 1.00000, 0.25000], -[7440, 0.50000, 0.75000, 0.00000], -[7441, 1.00000, 0.13194, 0.28750], -[7442, 0.73368, 0.71068, 0.36116], -[7443, 0.70172, 0.73291, 0.31793], -[7444, 1.00000, 0.11029, 0.27500], -[7445, 0.54294, 0.86816, 0.38035], -[7446, 0.69804, 0.73010, 0.29380], -[7447, 0.83638, 0.59547, 0.40648], -[7448, 0.62249, 0.72570, 0.11428], -[7449, 1.00000, 0.02369, 0.25000], -[7450, 0.78368, 0.56816, 0.14483], -[7451, 0.56777, 0.81922, 0.23605], -[7452, 0.83392, 0.58590, 0.34360], -[7453, 0.67321, 0.60000, 0.00000], -[7454, 0.57541, 0.73735, 0.06584], -[7455, 1.00000, 0.24019, 0.42500], -[7456, 0.72675, 0.72610, 0.41056], -[7457, 0.60158, 0.72438, 0.07953], -[7458, 0.57634, 0.85454, 0.46795], -[7459, 0.73973, 0.70176, 0.34584], -[7460, 0.53365, 0.76061, 0.05253], -[7461, 0.79849, 0.64449, 0.39686], -[7462, 1.00000, 0.15359, 0.30000], -[7463, 0.39175, 0.81250, 0.00000], -[7464, 0.81250, 0.39175, 0.00000], -[7465, 0.66124, 0.75415, 0.25985], -[7466, 0.61738, 0.78124, 0.23100], -[7467, 0.58283, 0.84602, 0.40728], -[7468, 0.88971, 0.50000, 0.35000], -[7469, 0.88971, 0.15000, 0.00000], -[7470, 0.50000, 0.89175, 0.36250], -[7471, 0.84440, 0.57842, 0.37134], -[7472, 0.63667, 0.80026, 0.36430], -[7473, 0.92500, 0.00000, 0.04330], -[7474, 0.00000, 0.92500, 0.04330], -[7475, 0.53982, 0.84230, 0.24833], -[7476, 1.00000, 0.08864, 0.26250], -[7477, 0.52399, 0.88660, 0.43921], -[7478, 0.81023, 0.58759, 0.24978], -[7479, 0.23816, 1.00000, 0.41250], -[7480, 0.19486, 1.00000, 0.33750], -[7481, 0.04330, 1.00000, 0.25000], -[7482, 0.66110, 0.79118, 0.46182], -[7483, 0.72809, 0.71389, 0.34253], -[7484, 0.52732, 0.86966, 0.32622], -[7485, 0.82397, 0.59601, 0.32554], -[7486, 0.69043, 0.68654, 0.15855], -[7487, 0.79956, 0.62580, 0.31627], -[7488, 0.83884, 0.59787, 0.44010], -[7489, 0.58750, 0.84845, 0.50000], -[7490, 0.71724, 0.73429, 0.39317], -[7491, 0.68857, 0.71942, 0.22910], -[7492, 0.74821, 0.68925, 0.32624], -[7493, 0.77301, 0.59897, 0.17015], -[7494, 0.56461, 0.73487, 0.04573], -[7495, 0.67180, 0.70873, 0.16590], -[7496, 0.81315, 0.55958, 0.19849], -[7497, 0.52031, 0.84506, 0.21642], -[7498, 0.74548, 0.70398, 0.38190], -[7499, 0.54528, 0.74564, 0.03957], -[7500, 0.79736, 0.64351, 0.37497], -[7501, 0.56115, 0.83107, 0.25488], -[7502, 0.85578, 0.52842, 0.26744], -[7503, 1.00000, 0.17524, 0.31250], -[7504, 0.71651, 0.55000, 0.00000], -[7505, 0.79644, 0.63661, 0.33755], -[7506, 0.52165, 0.73750, 0.00000], -[7507, 0.64359, 0.66857, 0.04740], -[7508, 0.54282, 0.87796, 0.47548], -[7509, 0.70050, 0.70257, 0.21402], -[7510, 0.71126, 0.74302, 0.40957], -[7511, 0.63623, 0.75376, 0.19448], -[7512, 0.65851, 0.77392, 0.31636], -[7513, 0.81698, 0.59163, 0.27894], -[7514, 0.50000, 0.78349, 0.05000], -[7515, 0.60689, 0.81152, 0.30107], -[7516, 0.55932, 0.78438, 0.12787], -[7517, 0.58967, 0.75884, 0.12179], -[7518, 1.00000, 0.21854, 0.36250], -[7519, 0.62118, 0.68388, 0.03831], -[7520, 0.66897, 0.78502, 0.44517], -[7521, 1.00000, 0.06699, 0.25000], -[7522, 0.86438, 0.26451, 0.00000], -[7523, 0.80000, 0.65359, 0.50000], -[7524, 0.60718, 0.75753, 0.14684], -[7525, 0.56837, 0.83783, 0.29446], -[7526, 0.82144, 0.62625, 0.48094], -[7527, 0.08660, 0.90000, 0.00000], -[7528, 0.12990, 1.00000, 0.27500], -[7529, 0.50000, 0.84845, 0.18750], -[7530, 0.37010, 0.82500, 0.00000], -[7531, 0.82500, 0.37010, 0.00000], -[7532, 0.79527, 0.62092, 0.27720], -[7533, 1.00000, 0.24019, 0.40000], -[7534, 0.76615, 0.48032, 0.00000], -[7535, 0.77298, 0.50901, 0.04048], -[7536, 0.62567, 0.79906, 0.30548], -[7537, 0.88151, 0.52499, 0.37689], -[7538, 0.58526, 0.74439, 0.08623], -[7539, 0.86614, 0.56189, 0.45569], -[7540, 0.63458, 0.78108, 0.26519], -[7541, 0.54214, 0.80901, 0.15428], -[7542, 0.73613, 0.71803, 0.39719], -[7543, 0.54305, 0.82409, 0.19337], -[7544, 0.82784, 0.55806, 0.23297], -[7545, 0.59123, 0.83776, 0.37087], -[7546, 0.15155, 1.00000, 0.28750], -[7547, 0.10825, 1.00000, 0.26250], -[7548, 0.93750, 0.00000, 0.06495], -[7549, 0.00000, 0.93750, 0.06495], -[7550, 0.73267, 0.60797, 0.09772], -[7551, 0.50000, 0.80514, 0.08750], -[7552, 0.26063, 1.00000, 0.47685], -[7553, 0.75511, 0.70584, 0.48919], -[7554, 0.71734, 0.66564, 0.16682], -[7555, 0.74269, 0.61076, 0.12045], -[7556, 0.60773, 0.73364, 0.09861], -[7557, 0.52366, 0.80292, 0.11291], -[7558, 0.85666, 0.55431, 0.33375], -[7559, 0.63180, 0.73220, 0.13424], -[7560, 0.58987, 0.81297, 0.25458], -[7561, 0.62990, 0.65000, 0.00000], -[7562, 0.23816, 1.00000, 0.38750], -[7563, 0.21651, 1.00000, 0.35000], -[7564, 0.02165, 1.00000, 0.23750], -[7565, 1.00000, 0.19689, 0.32500], -[7566, 0.53935, 0.85962, 0.30108], -[7567, 0.79409, 0.66234, 0.48725], -[7568, 0.82901, 0.61624, 0.44975], -[7569, 0.50000, 0.87010, 0.25000], -[7570, 1.00000, 0.26203, 0.46964], -[7571, 0.86666, 0.54062, 0.33785], -[7572, 0.67567, 0.73777, 0.23755], -[7573, 0.63163, 0.81723, 0.44516], -[7574, 0.74415, 0.71373, 0.41821], -[7575, 0.25981, 1.00000, 0.45000], -[7576, 0.17321, 1.00000, 0.30000], -[7577, 0.08660, 1.00000, 0.25000], -[7578, 0.68561, 0.68394, 0.13625], -[7579, 0.65527, 0.73612, 0.18548], -[7580, 0.53492, 0.80575, 0.13273], -[7581, 0.51649, 0.79834, 0.09238], -[7582, 0.87413, 0.54974, 0.43598], -[7583, 0.70602, 0.74588, 0.37509], -[7584, 0.83890, 0.57886, 0.32232], -[7585, 0.71588, 0.57908, 0.02817], -[7586, 0.58564, 0.80960, 0.23165], -[7587, 0.65189, 0.65110, 0.02932], -[7588, 0.80822, 0.53337, 0.13525], -[7589, 0.57904, 0.80020, 0.19154], -[7590, 0.71081, 0.64531, 0.11390], -[7591, 0.73463, 0.72620, 0.43872], -[7592, 0.54330, 0.72500, 0.00000], -[7593, 0.76035, 0.62999, 0.19039], -[7594, 0.52644, 0.87784, 0.34765], -[7595, 0.59951, 0.82778, 0.33778], -[7596, 1.00000, 0.04534, 0.23750], -[7597, 0.65606, 0.74369, 0.20412], -[7598, 0.57597, 0.84440, 0.33756], -[7599, 0.88572, 0.52895, 0.41709], -[7600, 0.85293, 0.54904, 0.29447], -[7601, 0.84526, 0.56598, 0.30912], -[7602, 0.86532, 0.56761, 0.48095], -[7603, 0.72793, 0.62225, 0.10720], -[7604, 0.82977, 0.57721, 0.27704], -[7605, 0.70153, 0.69600, 0.19204], -[7606, 0.77848, 0.66314, 0.33975], -[7607, 0.50000, 0.89175, 0.33750], -[7608, 0.78845, 0.66723, 0.43090], -[7609, 0.75479, 0.69222, 0.34907], -[7610, 0.63977, 0.79929, 0.34618], -[7611, 0.52988, 0.88945, 0.50000], -[7612, 0.52277, 0.86720, 0.28415], -[7613, 0.67408, 0.77306, 0.35892], -[7614, 0.58067, 0.75935, 0.10233], -[7615, 0.65255, 0.76045, 0.23955], -[7616, 0.84641, 0.50000, 0.17500], -[7617, 0.55645, 0.87083, 0.43612], -[7618, 0.62197, 0.72342, 0.09759], -[7619, 0.88971, 0.50000, 0.32500], -[7620, 0.88971, 0.17500, 0.00000], -[7621, 0.55340, 0.81223, 0.17403], -[7622, 0.74600, 0.68945, 0.29903], -[7623, 0.84262, 0.52859, 0.21202], -[7624, 0.86806, 0.50000, 0.23750], -[7625, 1.00000, 0.26184, 0.43750], -[7626, 0.68825, 0.77204, 0.44768], -[7627, 0.78655, 0.62147, 0.23994], -[7628, 0.58500, 0.82382, 0.27219], -[7629, 0.65337, 0.69496, 0.09634], -[7630, 0.34845, 0.83750, 0.00000], -[7631, 0.83750, 0.34845, 0.00000], -[7632, 0.54486, 0.86633, 0.34043], -[7633, 0.52886, 0.88377, 0.38961], -[7634, 0.81551, 0.55120, 0.17724], -[7635, 0.72088, 0.64243, 0.12488], -[7636, 0.25981, 1.00000, 0.42500], -[7637, 0.19486, 1.00000, 0.31250], -[7638, 0.06495, 1.00000, 0.23750], -[7639, 0.71045, 0.73652, 0.33886], -[7640, 0.72586, 0.70098, 0.26557], -[7641, 0.61783, 0.83010, 0.45016], -[7642, 0.24019, 0.87500, 0.00000], -[7643, 1.00000, 0.24019, 0.37500], -[7644, 0.75689, 0.67471, 0.28726], -[7645, 0.95000, 0.00000, 0.08660], -[7646, 0.00000, 0.95000, 0.08660], -[7647, 0.57436, 0.77363, 0.11916], -[7648, 0.69473, 0.66013, 0.10623], -[7649, 0.79717, 0.65597, 0.41151], -[7650, 0.86421, 0.53116, 0.28855], -[7651, 0.78955, 0.65568, 0.35694], -[7652, 0.79722, 0.60038, 0.22115], -[7653, 0.60182, 0.79547, 0.21920], -[7654, 1.00000, 0.13194, 0.26250], -[7655, 0.75000, 0.66475, 0.23609], -[7656, 1.00000, 0.21854, 0.33750], -[7657, 0.86112, 0.56720, 0.39536], -[7658, 0.65806, 0.72708, 0.16455], -[7659, 0.50000, 0.82679, 0.12500], -[7660, 1.00000, 0.15359, 0.27500], -[7661, 0.62500, 0.82679, 0.50000], -[7662, 0.56164, 0.76409, 0.08157], -[7663, 0.68333, 0.62385, 0.03274], -[7664, 0.76101, 0.69705, 0.40268], -[7665, 0.58574, 0.72635, 0.04853], -[7666, 0.63655, 0.77661, 0.24275], -[7667, 0.66226, 0.71448, 0.14582], -[7668, 0.79594, 0.53371, 0.10482], -[7669, 0.88136, 0.51984, 0.33405], -[7670, 1.00000, 0.11029, 0.25000], -[7671, 0.89473, 0.51040, 0.38333], -[7672, 0.73918, 0.69074, 0.27367], -[7673, 0.78038, 0.50000, 0.03542], -[7674, 0.52848, 0.75825, 0.03028], -[7675, 0.65326, 0.78728, 0.33134], -[7676, 0.72146, 0.74469, 0.50000], -[7677, 0.80256, 0.51714, 0.09554], -[7678, 0.86699, 0.55346, 0.36806], -[7679, 0.55537, 0.73276, 0.02032], -[7680, 0.70524, 0.68606, 0.17224], -[7681, 0.58400, 0.79132, 0.17095], -[7682, 0.80311, 0.50000, 0.07500], -[7683, 0.23816, 1.00000, 0.36250], -[7684, 1.00000, 0.27500, 0.50000], -[7685, 0.27500, 1.00000, 0.50000], -[7686, 1.00000, 0.00000, 0.22500], -[7687, 0.00000, 1.00000, 0.22500], -[7688, 1.00000, 0.17524, 0.28750], -[7689, 0.73797, 0.53036, 0.00000], -[7690, 0.81752, 0.63638, 0.44908], -[7691, 0.61792, 0.80425, 0.28228], -[7692, 0.66871, 0.70071, 0.12861], -[7693, 0.78750, 0.67524, 0.50000], -[7694, 1.00000, 0.02369, 0.22500], -[7695, 1.00000, 0.26184, 0.41250], -[7696, 0.66177, 0.79470, 0.41760], -[7697, 1.00000, 0.08864, 0.23750], -[7698, 0.66299, 0.75103, 0.22947], -[7699, 0.53706, 0.79170, 0.09802], -[7700, 0.56495, 0.71250, 0.00000], -[7701, 0.56335, 0.85036, 0.30933], -[7702, 0.12990, 0.90000, 0.00000], -[7703, 0.67912, 0.76898, 0.34390], -[7704, 0.79273, 0.63708, 0.29332], -[7705, 0.57968, 0.82269, 0.24658], -[7706, 0.72128, 0.69374, 0.22474], -[7707, 0.59866, 0.78868, 0.18843], -[7708, 0.25981, 1.00000, 0.40000], -[7709, 0.21651, 1.00000, 0.32500], -[7710, 0.04330, 1.00000, 0.22500], -[7711, 0.76109, 0.55813, 0.06786], -[7712, 0.66730, 0.67586, 0.08097], -[7713, 0.67956, 0.73159, 0.21600], -[7714, 0.71122, 0.75271, 0.42730], -[7715, 0.75224, 0.60538, 0.11868], -[7716, 0.60992, 0.80612, 0.26349], -[7717, 0.60724, 0.84178, 0.47493], -[7718, 0.69486, 0.58750, 0.00000], -[7719, 0.71813, 0.59369, 0.04189], -[7720, 0.86445, 0.51841, 0.25091], -[7721, 0.85959, 0.55063, 0.31029], -[7722, 0.78734, 0.53213, 0.08160], -[7723, 0.72817, 0.59145, 0.05494], -[7724, 0.51443, 0.90089, 0.45654], -[7725, 0.76695, 0.68094, 0.33739], -[7726, 0.56124, 0.84497, 0.27776], -[7727, 0.56497, 0.85622, 0.33834], -[7728, 0.77741, 0.56687, 0.10907], -[7729, 1.00000, 0.19689, 0.30000], -[7730, 0.86273, 0.57351, 0.42389], -[7731, 0.75873, 0.62466, 0.16356], -[7732, 0.62240, 0.79320, 0.24995], -[7733, 0.62553, 0.82906, 0.47897], -[7734, 0.51492, 0.84251, 0.17723], -[7735, 0.32679, 0.85000, 0.00000], -[7736, 0.85000, 0.32679, 0.00000], -[7737, 0.57769, 0.78401, 0.13820], -[7738, 0.12990, 1.00000, 0.25000], -[7739, 0.15155, 1.00000, 0.26250], -[7740, 0.52768, 0.84119, 0.19446], -[7741, 0.71352, 0.75396, 0.45414], -[7742, 0.87713, 0.51412, 0.28546], -[7743, 0.51387, 0.90299, 0.48325], -[7744, 0.62446, 0.68055, 0.02390], -[7745, 0.62885, 0.70291, 0.06382], -[7746, 0.58429, 0.83749, 0.30747], -[7747, 0.76461, 0.54018, 0.04897], -[7748, 0.28038, 1.00000, 0.46458], -[7749, 0.82827, 0.60814, 0.34455], -[7750, 0.51881, 0.78538, 0.05941], -[7751, 1.00000, 0.06699, 0.22500], -[7752, 1.00000, 0.24019, 0.35000], -[7753, 0.76167, 0.65042, 0.22245], -[7754, 0.71825, 0.72523, 0.30397], -[7755, 0.50000, 0.89175, 0.31250], -[7756, 0.82476, 0.50000, 0.11250], -[7757, 0.82361, 0.62504, 0.39258], -[7758, 0.17321, 1.00000, 0.27500], -[7759, 0.10825, 1.00000, 0.23750], -[7760, 0.87292, 0.55833, 0.41683], -[7761, 0.81627, 0.63086, 0.37187], -[7762, 0.51618, 0.89341, 0.37306], -[7763, 0.67039, 0.79441, 0.48243], -[7764, 0.75319, 0.57847, 0.07702], -[7765, 0.65155, 0.63750, 0.00000], -[7766, 1.00000, 0.28349, 0.47500], -[7767, 0.77765, 0.68896, 0.45962], -[7768, 0.51536, 0.89712, 0.39695], -[7769, 0.76351, 0.70509, 0.46783], -[7770, 1.00000, 0.26184, 0.38750], -[7771, 0.68795, 0.64329, 0.05930], -[7772, 0.81162, 0.52465, 0.11591], -[7773, 0.88971, 0.50000, 0.30000], -[7774, 0.88971, 0.20000, 0.00000], -[7775, 0.56969, 0.86383, 0.39565], -[7776, 0.69045, 0.77156, 0.40095], -[7777, 0.65112, 0.75857, 0.21272], -[7778, 0.55951, 0.75538, 0.05473], -[7779, 0.69805, 0.72848, 0.24687], -[7780, 0.69456, 0.64951, 0.07836], -[7781, 0.91169, 0.50000, 0.46964], -[7782, 0.91169, 0.03036, 0.00000], -[7783, 0.82927, 0.62727, 0.46735], -[7784, 0.59244, 0.78129, 0.15215], -[7785, 0.74954, 0.62680, 0.14263], -[7786, 0.84159, 0.59953, 0.37853], -[7787, 0.79233, 0.51622, 0.06617], -[7788, 0.63640, 0.79431, 0.28394], -[7789, 0.50000, 0.87010, 0.22500], -[7790, 0.55672, 0.80122, 0.13834], -[7791, 0.62264, 0.81458, 0.32213], -[7792, 1.00000, 0.28349, 0.45000], -[7793, 1.00000, 0.21854, 0.31250], -[7794, 0.54396, 0.83886, 0.21122], -[7795, 0.90047, 0.52127, 0.47795], -[7796, 0.02165, 0.91250, 0.00000], -[7797, 0.28146, 1.00000, 0.43750], -[7798, 0.19486, 1.00000, 0.28750], -[7799, 0.23816, 1.00000, 0.33750], -[7800, 0.25981, 1.00000, 0.37500], -[7801, 0.08660, 1.00000, 0.22500], -[7802, 0.02165, 1.00000, 0.21250], -[7803, 0.64286, 0.81498, 0.42315], -[7804, 0.73402, 0.73693, 0.46099], -[7805, 0.52755, 0.82392, 0.14468], -[7806, 0.77818, 0.68839, 0.43667], -[7807, 0.51288, 0.90347, 0.43444], -[7808, 0.75305, 0.71706, 0.45126], -[7809, 0.88998, 0.53717, 0.44405], -[7810, 0.78603, 0.67146, 0.37730], -[7811, 0.50000, 0.84845, 0.16250], -[7812, 0.76629, 0.57060, 0.08642], -[7813, 0.82166, 0.58011, 0.23132], -[7814, 0.53365, 0.89351, 0.47221], -[7815, 0.61810, 0.83207, 0.40220], -[7816, 0.58660, 0.70000, 0.00000], -[7817, 0.71693, 0.71248, 0.24991], -[7818, 0.80375, 0.55721, 0.14266], -[7819, 0.90000, 0.52369, 0.50000], -[7820, 0.73957, 0.68913, 0.25020], -[7821, 0.86253, 0.56567, 0.35695], -[7822, 0.51609, 0.88493, 0.31303], -[7823, 0.91136, 0.50000, 0.43750], -[7824, 0.91136, 0.06250, 0.00000], -[7825, 0.70809, 0.60069, 0.02852], -[7826, 0.76192, 0.68246, 0.30441], -[7827, 0.78765, 0.64180, 0.27143], -[7828, 0.72083, 0.68411, 0.18852], -[7829, 0.64290, 0.81037, 0.37900], -[7830, 1.00000, 0.04534, 0.21250], -[7831, 0.76420, 0.60930, 0.14013], -[7832, 0.66789, 0.77431, 0.30181], -[7833, 0.50000, 0.91345, 0.47685], -[7834, 0.96458, 0.00000, 0.10688], -[7835, 0.00000, 0.96458, 0.10688], -[7836, 0.60241, 0.75273, 0.10565], -[7837, 0.56871, 0.87219, 0.47013], -[7838, 0.88750, 0.54534, 0.50000], -[7839, 0.64593, 0.74640, 0.16719], -[7840, 0.72642, 0.56548, 0.01249], -[7841, 0.88198, 0.55379, 0.47529], -[7842, 0.62785, 0.82215, 0.37711], -[7843, 0.77836, 0.55168, 0.08155], -[7844, 0.80085, 0.57266, 0.15940], -[7845, 0.66655, 0.65893, 0.04517], -[7846, 0.21854, 0.88750, 0.00000], -[7847, 0.90966, 0.50778, 0.48745], -[7848, 0.75905, 0.71024, 0.43017], -[7849, 0.79012, 0.60561, 0.19270], -[7850, 0.71195, 0.75277, 0.39062], -[7851, 0.74378, 0.70974, 0.33079], -[7852, 0.82683, 0.59982, 0.29477], -[7853, 0.81328, 0.58122, 0.20616], -[7854, 0.77723, 0.63806, 0.22707], -[7855, 0.65405, 0.81112, 0.50000], -[7856, 0.61363, 0.70633, 0.04132], -[7857, 1.00000, 0.28349, 0.42500], -[7858, 0.75462, 0.64366, 0.18009], -[7859, 1.00000, 0.15359, 0.25000], -[7860, 0.74811, 0.66652, 0.21328], -[7861, 0.86806, 0.50000, 0.21250], -[7862, 0.74889, 0.56013, 0.03991], -[7863, 0.77500, 0.69689, 0.50000], -[7864, 0.73859, 0.54964, 0.01145], -[7865, 1.00000, 0.13194, 0.23750], -[7866, 0.63676, 0.77615, 0.21979], -[7867, 0.67667, 0.78580, 0.39492], -[7868, 0.77995, 0.68425, 0.40041], -[7869, 0.77764, 0.69389, 0.48205], -[7870, 0.60797, 0.84492, 0.44502], -[7871, 0.85354, 0.58818, 0.38996], -[7872, 0.79399, 0.56295, 0.12676], -[7873, 0.66326, 0.79808, 0.40071], -[7874, 0.71438, 0.61127, 0.04976], -[7875, 0.50000, 0.91340, 0.45000], -[7876, 0.06495, 0.91250, 0.00000], -[7877, 0.28146, 1.00000, 0.41250], -[7878, 0.21651, 1.00000, 0.30000], -[7879, 0.06495, 1.00000, 0.21250], -[7880, 0.56431, 0.82793, 0.21184], -[7881, 0.89479, 0.51592, 0.35802], -[7882, 0.71218, 0.64521, 0.09566], -[7883, 0.64247, 0.74338, 0.15123], -[7884, 0.30514, 0.86250, 0.00000], -[7885, 0.86250, 0.30514, 0.00000], -[7886, 0.73028, 0.73004, 0.35593], -[7887, 0.75407, 0.54232, 0.02637], -[7888, 0.78760, 0.65521, 0.30645], -[7889, 0.80345, 0.59027, 0.19479], -[7890, 0.87500, 0.56699, 0.50000], -[7891, 1.00000, 0.17524, 0.26250], -[7892, 0.67542, 0.72683, 0.17957], -[7893, 0.83329, 0.57464, 0.24954], -[7894, 0.56354, 0.86495, 0.35283], -[7895, 0.70464, 0.62591, 0.05377], -[7896, 1.00000, 0.26184, 0.36250], -[7897, 0.78241, 0.64213, 0.24907], -[7898, 0.70514, 0.71908, 0.22947], -[7899, 0.85798, 0.54820, 0.27447], -[7900, 0.81070, 0.62281, 0.29410], -[7901, 0.00000, 0.97500, 0.12990], -[7902, 0.97500, 0.00000, 0.12990], -[7903, 0.80481, 0.66222, 0.46305], -[7904, 0.57500, 0.87010, 0.50000], -[7905, 0.68290, 0.70443, 0.14627], -[7906, 1.00000, 0.11029, 0.22500], -[7907, 0.74536, 0.59765, 0.08160], -[7908, 0.68904, 0.66717, 0.09005], -[7909, 0.59987, 0.83342, 0.31689], -[7910, 0.61003, 0.83548, 0.36571], -[7911, 0.73270, 0.68276, 0.20812], -[7912, 0.91136, 0.50000, 0.41250], -[7913, 0.91136, 0.08750, 0.00000], -[7914, 0.78396, 0.59264, 0.15009], -[7915, 1.00000, 0.24019, 0.32500], -[7916, 0.62511, 0.82244, 0.35432], -[7917, 0.55833, 0.78829, 0.10597], -[7918, 0.71191, 0.72632, 0.26743], -[7919, 0.59308, 0.71739, 0.02870], -[7920, 0.57683, 0.71994, 0.01268], -[7921, 0.63593, 0.82116, 0.40047], -[7922, 0.84641, 0.50000, 0.15000], -[7923, 0.90223, 0.51687, 0.41172], -[7924, 0.79328, 0.67607, 0.44882], -[7925, 0.63451, 0.71449, 0.08056], -[7926, 0.66972, 0.79027, 0.37349], -[7927, 0.73709, 0.64606, 0.14167], -[7928, 0.61905, 0.77790, 0.18243], -[7929, 0.72906, 0.60963, 0.06861], -[7930, 0.55402, 0.88348, 0.45766], -[7931, 0.85865, 0.56748, 0.32679], -[7932, 0.60248, 0.70225, 0.01709], -[7933, 1.00000, 0.19689, 0.27500], -[7934, 0.80239, 0.54568, 0.11554], -[7935, 0.50000, 0.78349, 0.02500], -[7936, 0.85505, 0.53560, 0.23243], -[7937, 0.83156, 0.53024, 0.15802], -[7938, 0.90135, 0.52216, 0.43228], -[7939, 0.50000, 0.80514, 0.06250], -[7940, 0.55485, 0.84174, 0.22918], -[7941, 0.57549, 0.80659, 0.17126], -[7942, 0.67948, 0.66327, 0.06612], -[7943, 0.51812, 0.89030, 0.33026], -[7944, 0.50000, 0.91340, 0.42500], -[7945, 0.25981, 1.00000, 0.35000], -[7946, 1.00000, 0.30000, 0.50000], -[7947, 0.30000, 1.00000, 0.50000], -[7948, 1.00000, 0.00000, 0.20000], -[7949, 0.00000, 1.00000, 0.20000], -[7950, 0.62605, 0.76270, 0.15886], -[7951, 0.77067, 0.69439, 0.38201], -[7952, 0.56187, 0.87611, 0.41696], -[7953, 0.73795, 0.65677, 0.16196], -[7954, 0.77912, 0.68018, 0.35663], -[7955, 0.50000, 0.89175, 0.28750], -[7956, 1.00000, 0.28349, 0.40000], -[7957, 0.73976, 0.63316, 0.12286], -[7958, 0.86250, 0.58864, 0.50000], -[7959, 0.65824, 0.81017, 0.47212], -[7960, 0.59174, 0.85912, 0.45292], -[7961, 0.67591, 0.77589, 0.32224], -[7962, 0.80715, 0.65986, 0.44033], -[7963, 1.00000, 0.08864, 0.21250], -[7964, 1.00000, 0.02369, 0.20000], -[7965, 0.79661, 0.59077, 0.17287], -[7966, 0.84943, 0.60667, 0.46649], -[7967, 0.61511, 0.79054, 0.20431], -[7968, 0.65511, 0.77599, 0.25626], -[7969, 0.72309, 0.75305, 0.47152], -[7970, 0.69998, 0.77132, 0.42312], -[7971, 0.70836, 0.67311, 0.13118], -[7972, 0.65684, 0.71986, 0.12416], -[7973, 0.77043, 0.65663, 0.24275], -[7974, 0.88452, 0.53523, 0.35097], -[7975, 0.57818, 0.86866, 0.45224], -[7976, 0.70025, 0.76382, 0.36795], -[7977, 0.51385, 0.77428, 0.02277], -[7978, 0.75276, 0.72396, 0.47529], -[7979, 0.53825, 0.85323, 0.22820], -[7980, 0.83287, 0.61632, 0.36551], -[7981, 0.57745, 0.86795, 0.42950], -[7982, 0.70156, 0.72020, 0.21554], -[7983, 0.86450, 0.58641, 0.47526], -[7984, 0.59486, 0.85595, 0.42682], -[7985, 0.71103, 0.68213, 0.15213], -[7986, 0.28146, 1.00000, 0.38750], -[7987, 0.23816, 1.00000, 0.31250], -[7988, 0.15155, 1.00000, 0.23750], -[7989, 0.04330, 1.00000, 0.20000], -[7990, 0.82725, 0.52205, 0.13253], -[7991, 0.79434, 0.65715, 0.32909], -[7992, 0.64149, 0.73276, 0.12107], -[7993, 0.54011, 0.89455, 0.48940], -[7994, 0.64192, 0.82384, 0.46377], -[7995, 0.54903, 0.78307, 0.07871], -[7996, 0.76128, 0.70339, 0.36652], -[7997, 0.64001, 0.69125, 0.04749], -[7998, 0.88971, 0.50000, 0.27500], -[7999, 0.88971, 0.22500, 0.00000], -[8000, 0.54892, 0.87070, 0.31874], -[8001, 0.79906, 0.53327, 0.08839], -[8002, 0.86103, 0.58924, 0.43866], -[8003, 0.30311, 1.00000, 0.47500], -[8004, 0.17321, 1.00000, 0.25000], -[8005, 0.12990, 1.00000, 0.22500], -[8006, 0.65300, 0.80397, 0.35910], -[8007, 0.85687, 0.59281, 0.41649], -[8008, 0.60825, 0.68750, 0.00000], -[8009, 0.68984, 0.72475, 0.19732], -[8010, 0.88015, 0.52672, 0.29816], -[8011, 1.00000, 0.21854, 0.28750], -[8012, 0.86509, 0.58472, 0.44760], -[8013, 0.62713, 0.83419, 0.43763], -[8014, 0.84088, 0.59203, 0.31126], -[8015, 0.91136, 0.50000, 0.38750], -[8016, 0.91136, 0.11250, 0.00000], -[8017, 0.75517, 0.53184, 0.00995], -[8018, 0.74809, 0.57842, 0.05377], -[8019, 0.60590, 0.82380, 0.28169], -[8020, 0.50000, 0.82679, 0.10000], -[8021, 0.74233, 0.66487, 0.18299], -[8022, 0.72480, 0.66515, 0.14511], -[8023, 0.84370, 0.55042, 0.21904], -[8024, 0.83030, 0.56690, 0.21188], -[8025, 0.67321, 0.62500, 0.00000], -[8026, 1.00000, 0.30429, 0.46458], -[8027, 0.52880, 0.89952, 0.42874], -[8028, 0.89561, 0.53901, 0.46419], -[8029, 0.73494, 0.71399, 0.29018], -[8030, 0.58414, 0.84793, 0.31634], -[8031, 0.71651, 0.57500, 0.00000], -[8032, 0.53793, 0.88738, 0.36882], -[8033, 0.51710, 0.82174, 0.11086], -[8034, 0.89356, 0.51568, 0.32713], -[8035, 0.58163, 0.82019, 0.21142], -[8036, 0.50000, 0.91340, 0.40000], -[8037, 0.10825, 0.91250, 0.00000], -[8038, 0.30311, 1.00000, 0.45000], -[8039, 0.19486, 1.00000, 0.26250], -[8040, 0.10825, 1.00000, 0.21250], -[8041, 1.00000, 0.06699, 0.20000], -[8042, 0.77308, 0.63991, 0.20395], -[8043, 0.81987, 0.64960, 0.47494], -[8044, 0.82202, 0.62131, 0.31799], -[8045, 0.61564, 0.70150, 0.02694], -[8046, 0.85000, 0.61029, 0.50000], -[8047, 1.00000, 0.26184, 0.33750], -[8048, 0.61250, 0.84845, 0.50000], -[8049, 0.82840, 0.63547, 0.42888], -[8050, 0.62793, 0.75461, 0.13745], -[8051, 0.61058, 0.76260, 0.12470], -[8052, 0.66238, 0.79626, 0.34986], -[8053, 0.79155, 0.67100, 0.36316], -[8054, 0.65757, 0.78609, 0.28736], -[8055, 0.68132, 0.79137, 0.42773], -[8056, 0.65628, 0.81401, 0.44880], -[8057, 0.68752, 0.63924, 0.03670], -[8058, 0.80018, 0.62963, 0.25652], -[8059, 0.28349, 0.87500, 0.00000], -[8060, 0.87500, 0.28349, 0.00000], -[8061, 1.00000, 0.28349, 0.37500], -[8062, 0.59059, 0.85722, 0.38880], -[8063, 0.73247, 0.67062, 0.16870], -[8064, 0.58014, 0.83920, 0.26493], -[8065, 0.69162, 0.77670, 0.37968], -[8066, 0.57843, 0.80066, 0.15290], -[8067, 0.82281, 0.62980, 0.34988], -[8068, 0.62154, 0.72913, 0.07768], -[8069, 0.75530, 0.60661, 0.10243], -[8070, 0.61396, 0.80630, 0.23635], -[8071, 0.70130, 0.73923, 0.25852], -[8072, 0.64354, 0.80592, 0.31817], -[8073, 0.80031, 0.66662, 0.39021], -[8074, 0.90621, 0.52282, 0.45105], -[8075, 0.77934, 0.62392, 0.18322], -[8076, 0.66712, 0.80510, 0.43859], -[8077, 1.00000, 0.30514, 0.43750], -[8078, 0.50000, 0.87010, 0.20000], -[8079, 0.71378, 0.75280, 0.35545], -[8080, 0.88402, 0.54569, 0.36643], -[8081, 0.73765, 0.57904, 0.03332], -[8082, 0.60983, 0.72224, 0.04847], -[8083, 0.85106, 0.55378, 0.24226], -[8084, 0.78007, 0.67463, 0.31611], -[8085, 0.80311, 0.50000, 0.05000], -[8086, 0.30311, 1.00000, 0.42500], -[8087, 0.21651, 1.00000, 0.27500], -[8088, 0.08660, 1.00000, 0.20000], -[8089, 0.79290, 0.62393, 0.21801], -[8090, 0.60090, 0.77754, 0.13667], -[8091, 0.52829, 0.77907, 0.03997], -[8092, 1.00000, 0.24019, 0.30000], -[8093, 0.76250, 0.71854, 0.50000], -[8094, 0.85283, 0.56874, 0.28334], -[8095, 0.84654, 0.60043, 0.35613], -[8096, 0.77166, 0.59360, 0.11256], -[8097, 0.52052, 0.86805, 0.22892], -[8098, 0.83756, 0.62337, 0.41057], -[8099, 0.28146, 1.00000, 0.36250], -[8100, 0.25981, 1.00000, 0.32500], -[8101, 0.02165, 1.00000, 0.18750], -[8102, 0.69528, 0.76502, 0.32808], -[8103, 0.77273, 0.66873, 0.26779], -[8104, 0.69493, 0.71495, 0.17719], -[8105, 0.86367, 0.51941, 0.21230], -[8106, 0.65470, 0.81395, 0.41428], -[8107, 0.45670, 0.80000, 0.00000], -[8108, 0.80000, 0.45670, 0.00000], -[8109, 0.72859, 0.64345, 0.10794], -[8110, 0.61114, 0.74096, 0.08035], -[8111, 0.60226, 0.82555, 0.26664], -[8112, 0.70766, 0.64225, 0.06935], -[8113, 0.19689, 0.90000, 0.00000], -[8114, 0.88410, 0.53126, 0.31306], -[8115, 0.70997, 0.76916, 0.44369], -[8116, 0.78376, 0.58772, 0.12683], -[8117, 0.78502, 0.52872, 0.04926], -[8118, 0.47835, 0.78750, 0.00000], -[8119, 0.78750, 0.47835, 0.00000], -[8120, 0.58843, 0.84088, 0.28632], -[8121, 0.54632, 0.80662, 0.11281], -[8122, 0.85678, 0.58379, 0.34407], -[8123, 1.00000, 0.15359, 0.22500], -[8124, 0.58855, 0.85419, 0.34763], -[8125, 0.85385, 0.52497, 0.19232], -[8126, 0.43505, 0.81250, 0.00000], -[8127, 0.81250, 0.43505, 0.00000], -[8128, 0.91136, 0.50000, 0.36250], -[8129, 0.91136, 0.13750, 0.00000], -[8130, 1.00000, 0.17524, 0.23750], -[8131, 1.00000, 0.04534, 0.18750], -[8132, 0.68503, 0.68822, 0.10379], -[8133, 0.50000, 0.91340, 0.37500], -[8134, 0.72075, 0.70174, 0.20322], -[8135, 1.00000, 0.13194, 0.21250], -[8136, 0.66009, 0.68276, 0.05472], -[8137, 0.90120, 0.52616, 0.39391], -[8138, 0.67213, 0.78816, 0.33471], -[8139, 0.82476, 0.50000, 0.08750], -[8140, 0.69632, 0.78457, 0.50000], -[8141, 0.57988, 0.73618, 0.02863], -[8142, 0.54917, 0.89133, 0.43369], -[8143, 0.55871, 0.86135, 0.28465], -[8144, 0.54767, 0.75412, 0.01836], -[8145, 0.77500, 0.50000, 0.00000], -[8146, 0.50000, 0.77500, 0.00000], -[8147, 0.51609, 0.90948, 0.41537], -[8148, 0.56227, 0.87656, 0.37259], -[8149, 0.83750, 0.63194, 0.50000], -[8150, 1.00000, 0.30514, 0.41250], -[8151, 0.87632, 0.57390, 0.44056], -[8152, 0.85070, 0.56623, 0.26201], -[8153, 0.86099, 0.54341, 0.24611], -[8154, 0.77914, 0.67214, 0.29445], -[8155, 0.80419, 0.65724, 0.35022], -[8156, 0.86806, 0.50000, 0.18750], -[8157, 0.89828, 0.54236, 0.48675], -[8158, 0.50000, 0.84845, 0.13750], -[8159, 1.00000, 0.19689, 0.25000], -[8160, 0.89077, 0.54661, 0.40504], -[8161, 0.84265, 0.54501, 0.19310], -[8162, 0.69665, 0.73734, 0.23094], -[8163, 0.67335, 0.74542, 0.19615], -[8164, 0.74632, 0.68526, 0.22644], -[8165, 0.81204, 0.65966, 0.41700], -[8166, 0.53804, 0.87057, 0.26734], -[8167, 0.41340, 0.82500, 0.00000], -[8168, 0.82500, 0.41340, 0.00000], -[8169, 0.50000, 0.89175, 0.26250], -[8170, 0.60475, 0.85279, 0.40633], -[8171, 0.30311, 1.00000, 0.40000], -[8172, 0.23816, 1.00000, 0.28750], -[8173, 0.06495, 1.00000, 0.18750], -[8174, 0.68927, 0.76763, 0.30581], -[8175, 1.00000, 0.11029, 0.20000], -[8176, 0.78106, 0.69605, 0.41260], -[8177, 0.76063, 0.52315, 0.00000], -[8178, 0.74200, 0.73900, 0.42460], -[8179, 0.62990, 0.67500, 0.00000], -[8180, 0.53963, 0.89951, 0.45282], -[8181, 0.66241, 0.79335, 0.31456], -[8182, 0.52448, 0.84283, 0.15734], -[8183, 1.00000, 0.28349, 0.35000], -[8184, 0.81925, 0.51788, 0.09534], -[8185, 0.67603, 0.76711, 0.25921], -[8186, 0.52165, 0.76250, 0.00000], -[8187, 0.51904, 0.88344, 0.26835], -[8188, 0.75961, 0.68734, 0.26739], -[8189, 0.73260, 0.74652, 0.40183], -[8190, 0.55863, 0.83324, 0.18806], -[8191, 1.00000, 0.26184, 0.31250], -[8192, 0.72473, 0.63015, 0.07405], -[8193, 0.83996, 0.62086, 0.38688], -[8194, 0.82586, 0.64282, 0.40699], -[8195, 0.72321, 0.74067, 0.32022], -[8196, 0.76195, 0.71475, 0.38808], -[8197, 0.62730, 0.84210, 0.46375], -[8198, 0.76740, 0.58812, 0.08855], -[8199, 0.88971, 0.50000, 0.25000], -[8200, 1.00000, 0.21854, 0.26250], -[8201, 0.82167, 0.59998, 0.23716], -[8202, 0.60102, 0.80818, 0.20020], -[8203, 0.78601, 0.51573, 0.03035], -[8204, 0.70624, 0.77798, 0.48072], -[8205, 0.77379, 0.70918, 0.44704], -[8206, 0.55019, 0.88351, 0.35436], -[8207, 0.64464, 0.81547, 0.34513], -[8208, 0.84262, 0.51946, 0.14688], -[8209, 0.53910, 0.84264, 0.17762], -[8210, 0.54444, 0.83151, 0.15825], -[8211, 0.81363, 0.65056, 0.36037], -[8212, 0.79608, 0.55195, 0.09217], -[8213, 0.67312, 0.65311, 0.02541], -[8214, 0.39175, 0.83750, 0.00000], -[8215, 0.83750, 0.39175, 0.00000], -[8216, 0.79846, 0.67694, 0.40459], -[8217, 0.65245, 0.72153, 0.10162], -[8218, 0.73648, 0.73213, 0.33691], -[8219, 0.84697, 0.61864, 0.42950], -[8220, 0.68359, 0.74784, 0.21977], -[8221, 0.76368, 0.67756, 0.24936], -[8222, 0.75473, 0.70802, 0.31473], -[8223, 0.58258, 0.74907, 0.04744], -[8224, 0.65522, 0.75903, 0.18397], -[8225, 0.59591, 0.77403, 0.11124], -[8226, 0.60646, 0.79167, 0.16702], -[8227, 0.68478, 0.79623, 0.44991], -[8228, 0.57866, 0.86804, 0.36919], -[8229, 1.00000, 0.08864, 0.18750], -[8230, 0.54822, 0.76821, 0.03649], -[8231, 0.85660, 0.57632, 0.30092], -[8232, 0.52205, 0.91272, 0.50000], -[8233, 0.64223, 0.77458, 0.19478], -[8234, 0.28146, 1.00000, 0.33750], -[8235, 0.15155, 1.00000, 0.21250], -[8236, 0.17321, 1.00000, 0.22500], -[8237, 1.00000, 0.32500, 0.50000], -[8238, 0.92500, 0.00000, 0.00000], -[8239, 0.00000, 0.92500, 0.00000], -[8240, 0.32500, 1.00000, 0.50000], -[8241, 1.00000, 0.00000, 0.17500], -[8242, 0.00000, 1.00000, 0.17500], -[8243, 0.50000, 0.92500, 0.50000], -[8244, 0.92500, 0.50000, 0.50000], -[8245, 0.81914, 0.61802, 0.27039], -[8246, 0.69353, 0.75351, 0.26144], -[8247, 0.76425, 0.70286, 0.33390], -[8248, 1.00000, 0.30514, 0.38750], -[8249, 0.81757, 0.65091, 0.38299], -[8250, 0.62628, 0.75080, 0.11280], -[8251, 0.68092, 0.80143, 0.50000], -[8252, 0.84492, 0.58960, 0.28879], -[8253, 1.00000, 0.02369, 0.17500], -[8254, 0.26184, 0.88750, 0.00000], -[8255, 0.88750, 0.26184, 0.00000], -[8256, 0.63811, 0.76948, 0.17277], -[8257, 0.71288, 0.74733, 0.30083], -[8258, 0.56563, 0.75373, 0.03266], -[8259, 0.89225, 0.55474, 0.44863], -[8260, 0.75721, 0.62461, 0.12175], -[8261, 0.50000, 0.91340, 0.35000], -[8262, 0.32476, 1.00000, 0.46250], -[8263, 0.19486, 1.00000, 0.23750], -[8264, 0.12990, 1.00000, 0.20000], -[8265, 0.87803, 0.56619, 0.37568], -[8266, 0.91136, 0.50000, 0.33750], -[8267, 0.91136, 0.16250, 0.00000], -[8268, 0.84641, 0.50000, 0.12500], -[8269, 0.80314, 0.66670, 0.36720], -[8270, 0.83336, 0.60225, 0.27647], -[8271, 0.84711, 0.60156, 0.33320], -[8272, 0.54501, 0.89588, 0.41244], -[8273, 0.60242, 0.82262, 0.23981], -[8274, 0.79950, 0.58151, 0.13943], -[8275, 1.00000, 0.32679, 0.47500], -[8276, 0.51608, 0.84182, 0.13599], -[8277, 0.04330, 0.92500, 0.00000], -[8278, 0.30311, 1.00000, 0.37500], -[8279, 0.25981, 1.00000, 0.30000], -[8280, 0.04330, 1.00000, 0.17500], -[8281, 0.79255, 0.68838, 0.42561], -[8282, 0.60199, 0.86305, 0.48179], -[8283, 0.67682, 0.68774, 0.07983], -[8284, 0.54077, 0.88722, 0.33239], -[8285, 0.54330, 0.75000, 0.00000], -[8286, 0.93750, 0.00000, 0.02165], -[8287, 0.00000, 0.93750, 0.02165], -[8288, 0.82500, 0.65359, 0.50000], -[8289, 0.71913, 0.66386, 0.11272], -[8290, 0.70400, 0.69609, 0.14268], -[8291, 0.65180, 0.70208, 0.06396], -[8292, 0.87982, 0.51294, 0.23396], -[8293, 0.69486, 0.61250, 0.00000], -[8294, 0.70615, 0.74874, 0.27901], -[8295, 0.58802, 0.86834, 0.40873], -[8296, 0.56476, 0.85611, 0.26269], -[8297, 0.65038, 0.82763, 0.48475], -[8298, 0.81517, 0.51367, 0.07591], -[8299, 0.69367, 0.76254, 0.28633], -[8300, 0.75634, 0.64547, 0.15413], -[8301, 1.00000, 0.24019, 0.27500], -[8302, 0.53675, 0.80094, 0.07700], -[8303, 0.56828, 0.88422, 0.43864], -[8304, 0.60733, 0.83619, 0.29872], -[8305, 0.80009, 0.68379, 0.46935], -[8306, 0.56726, 0.81696, 0.15438], -[8307, 0.74994, 0.62787, 0.10989], -[8308, 0.74972, 0.72865, 0.37400], -[8309, 0.70132, 0.77105, 0.34940], -[8310, 0.84219, 0.60485, 0.31553], -[8311, 0.72943, 0.75653, 0.43091], -[8312, 0.88486, 0.51646, 0.25609], -[8313, 1.00000, 0.32679, 0.45000], -[8314, 0.63481, 0.79618, 0.23086], -[8315, 0.32476, 1.00000, 0.43750], -[8316, 0.21651, 1.00000, 0.25000], -[8317, 0.10825, 1.00000, 0.18750], -[8318, 0.74311, 0.72214, 0.31097], -[8319, 0.37010, 0.85000, 0.00000], -[8320, 0.85000, 0.37010, 0.00000], -[8321, 0.81363, 0.64564, 0.32479], -[8322, 0.53543, 0.88714, 0.31007], -[8323, 0.82658, 0.55993, 0.16380], -[8324, 0.89729, 0.51595, 0.30364], -[8325, 0.76739, 0.56608, 0.05213], -[8326, 0.70219, 0.78435, 0.45904], -[8327, 0.61376, 0.83795, 0.32346], -[8328, 1.00000, 0.06699, 0.17500], -[8329, 0.85293, 0.61102, 0.40308], -[8330, 0.68050, 0.72606, 0.15360], -[8331, 0.63297, 0.80892, 0.26497], -[8332, 0.82036, 0.59867, 0.21918], -[8333, 0.52633, 0.87692, 0.24650], -[8334, 0.56264, 0.77567, 0.06176], -[8335, 0.77597, 0.52316, 0.01575], -[8336, 0.89166, 0.55667, 0.42640], -[8337, 0.87376, 0.53064, 0.24444], -[8338, 0.74114, 0.74710, 0.44608], -[8339, 0.68333, 0.66037, 0.04466], -[8340, 0.75000, 0.74019, 0.50000], -[8341, 0.67878, 0.80529, 0.46407], -[8342, 0.63333, 0.83748, 0.41022], -[8343, 0.57562, 0.79667, 0.11974], -[8344, 0.57541, 0.84472, 0.24315], -[8345, 0.55134, 0.82249, 0.13919], -[8346, 0.54885, 0.89948, 0.47598], -[8347, 0.52162, 0.86647, 0.20330], -[8348, 0.72073, 0.76389, 0.41103], -[8349, 0.64957, 0.67605, 0.01841], -[8350, 0.55576, 0.85772, 0.24237], -[8351, 0.71489, 0.75719, 0.33711], -[8352, 1.00000, 0.28349, 0.32500], -[8353, 0.57984, 0.82245, 0.18634], -[8354, 0.52112, 0.89263, 0.29336], -[8355, 0.76910, 0.62714, 0.14470], -[8356, 0.95000, 0.00000, 0.04330], -[8357, 0.00000, 0.95000, 0.04330], -[8358, 0.59005, 0.87292, 0.46956], -[8359, 0.53337, 0.81421, 0.09543], -[8360, 0.88130, 0.56853, 0.39388], -[8361, 0.77602, 0.53640, 0.02957], -[8362, 0.60318, 0.81754, 0.21882], -[8363, 0.73816, 0.56250, 0.00000], -[8364, 0.74579, 0.74487, 0.48172], -[8365, 0.84920, 0.62292, 0.45195], -[8366, 0.88876, 0.54079, 0.32908], -[8367, 0.55266, 0.89143, 0.39281], -[8368, 0.56250, 0.89175, 0.50000], -[8369, 0.64514, 0.79609, 0.25137], -[8370, 0.89248, 0.54923, 0.38279], -[8371, 1.00000, 0.30514, 0.36250], -[8372, 0.60901, 0.74208, 0.06345], -[8373, 0.72514, 0.73388, 0.28148], -[8374, 0.80878, 0.62115, 0.23109], -[8375, 0.53044, 0.82983, 0.12267], -[8376, 0.90931, 0.51961, 0.37540], -[8377, 1.00000, 0.32679, 0.42500], -[8378, 0.62464, 0.82474, 0.29493], -[8379, 0.82850, 0.57456, 0.19031], -[8380, 0.59588, 0.80851, 0.17793], -[8381, 0.51467, 0.92015, 0.46894], -[8382, 0.70242, 0.71003, 0.16086], -[8383, 0.51951, 0.86185, 0.18383], -[8384, 0.79566, 0.65835, 0.28518], -[8385, 0.50000, 0.87010, 0.17500], -[8386, 0.87930, 0.56129, 0.34345], -[8387, 0.50000, 0.80429, 0.03542], -[8388, 0.69124, 0.70310, 0.12492], -[8389, 0.86455, 0.58926, 0.36497], -[8390, 0.56495, 0.73750, 0.00000], -[8391, 0.08660, 0.92500, 0.00000], -[8392, 0.32476, 1.00000, 0.41250], -[8393, 0.23816, 1.00000, 0.26250], -[8394, 0.08660, 1.00000, 0.17500], -[8395, 0.82310, 0.54223, 0.12368], -[8396, 0.61748, 0.85224, 0.42544], -[8397, 0.77316, 0.65779, 0.21227], -[8398, 0.67990, 0.76346, 0.23898], -[8399, 0.57734, 0.86804, 0.33728], -[8400, 0.17524, 0.91250, 0.00000], -[8401, 1.00000, 0.17524, 0.21250], -[8402, 0.55820, 0.87233, 0.29783], -[8403, 0.65155, 0.66250, 0.00000], -[8404, 0.66871, 0.74665, 0.17011], -[8405, 0.88054, 0.54355, 0.29334], -[8406, 0.86169, 0.60635, 0.44213], -[8407, 1.00000, 0.15359, 0.20000], -[8408, 1.00000, 0.26184, 0.28750], -[8409, 0.61839, 0.81935, 0.25497], -[8410, 0.87303, 0.56188, 0.31049], -[8411, 0.87781, 0.57852, 0.40725], -[8412, 0.64621, 0.82321, 0.36335], -[8413, 0.76364, 0.65898, 0.18919], -[8414, 0.84787, 0.57068, 0.23641], -[8415, 0.54410, 0.78713, 0.05454], -[8416, 0.50000, 0.89175, 0.23750], -[8417, 0.65789, 0.77934, 0.22805], -[8418, 0.50000, 0.82679, 0.07500], -[8419, 0.30311, 1.00000, 0.35000], -[8420, 0.28146, 1.00000, 0.31250], -[8421, 0.02165, 1.00000, 0.16250], -[8422, 1.00000, 0.19689, 0.22500], -[8423, 0.53436, 0.90970, 0.46378], -[8424, 0.71764, 0.70427, 0.17804], -[8425, 0.77345, 0.71849, 0.48361], -[8426, 0.52956, 0.90058, 0.34732], -[8427, 0.58936, 0.83310, 0.22910], -[8428, 0.79168, 0.69632, 0.44366], -[8429, 0.85039, 0.53106, 0.16880], -[8430, 0.61984, 0.77580, 0.14106], -[8431, 0.90571, 0.53568, 0.41257], -[8432, 0.50000, 0.91340, 0.32500], -[8433, 0.70422, 0.62931, 0.02766], -[8434, 1.00000, 0.13194, 0.18750], -[8435, 0.34845, 0.86250, 0.00000], -[8436, 0.86250, 0.34845, 0.00000], -[8437, 0.74707, 0.62033, 0.08479], -[8438, 0.60206, 0.73433, 0.03777], -[8439, 0.58302, 0.76821, 0.06928], -[8440, 0.82539, 0.65743, 0.45406], -[8441, 0.75459, 0.72455, 0.35406], -[8442, 0.91136, 0.50000, 0.31250], -[8443, 0.91136, 0.18750, 0.00000], -[8444, 0.72348, 0.69026, 0.15963], -[8445, 1.00000, 0.04534, 0.16250], -[8446, 0.79986, 0.67351, 0.34952], -[8447, 0.81250, 0.67524, 0.50000], -[8448, 0.78901, 0.57030, 0.08971], -[8449, 0.75254, 0.56331, 0.01782], -[8450, 0.61286, 0.85971, 0.46190], -[8451, 0.83488, 0.63796, 0.38902], -[8452, 0.85770, 0.59068, 0.32107], -[8453, 0.65789, 0.68270, 0.03338], -[8454, 1.00000, 0.21854, 0.23750], -[8455, 0.67865, 0.72124, 0.13122], -[8456, 1.00000, 0.32679, 0.40000], -[8457, 0.59611, 0.83601, 0.24976], -[8458, 0.73132, 0.71647, 0.23773], -[8459, 0.56220, 0.87964, 0.33523], -[8460, 0.60000, 0.87010, 0.50000], -[8461, 0.69636, 0.66431, 0.06315], -[8462, 0.76700, 0.72160, 0.40985], -[8463, 0.65733, 0.71585, 0.08445], -[8464, 0.88971, 0.50000, 0.22500], -[8465, 0.79817, 0.57209, 0.10903], -[8466, 0.58339, 0.85825, 0.29882], -[8467, 0.87161, 0.55875, 0.28665], -[8468, 0.86806, 0.50000, 0.16250], -[8469, 0.61293, 0.85359, 0.38489], -[8470, 0.73264, 0.61350, 0.04776], -[8471, 0.62406, 0.78296, 0.16059], -[8472, 0.24019, 0.90000, 0.00000], -[8473, 0.88750, 0.57420, 0.48125], -[8474, 0.90251, 0.52668, 0.33922], -[8475, 0.68190, 0.67686, 0.05881], -[8476, 1.00000, 0.11029, 0.17500], -[8477, 0.87145, 0.57597, 0.33664], -[8478, 0.80540, 0.61759, 0.20358], -[8479, 0.73436, 0.72269, 0.26246], -[8480, 0.32476, 1.00000, 0.38750], -[8481, 0.25981, 1.00000, 0.27500], -[8482, 0.06495, 1.00000, 0.16250], -[8483, 0.64622, 0.83504, 0.44289], -[8484, 0.68752, 0.63956, 0.01374], -[8485, 0.59174, 0.85962, 0.32923], -[8486, 0.66339, 0.66924, 0.02005], -[8487, 0.61948, 0.84319, 0.34626], -[8488, 0.57185, 0.78465, 0.08079], -[8489, 0.79712, 0.55090, 0.07628], -[8490, 0.00000, 0.96473, 0.06670], -[8491, 0.81803, 0.64091, 0.30360], -[8492, 0.65899, 0.74275, 0.13588], -[8493, 0.53274, 0.90838, 0.40184], -[8494, 0.65207, 0.80708, 0.29485], -[8495, 0.79919, 0.63956, 0.23360], -[8496, 0.62089, 0.80684, 0.21310], -[8497, 0.53564, 0.88622, 0.28398], -[8498, 0.57171, 0.87085, 0.31634], -[8499, 0.73692, 0.58084, 0.01151], -[8500, 0.71195, 0.72353, 0.20200], -[8501, 0.68797, 0.79134, 0.35960], -[8502, 0.82777, 0.63597, 0.32796], -[8503, 0.65973, 0.82087, 0.39825], -[8504, 1.00000, 0.30514, 0.33750], -[8505, 0.83379, 0.54699, 0.14619], -[8506, 0.79519, 0.60972, 0.15999], -[8507, 0.62544, 0.72841, 0.05506], -[8508, 0.58660, 0.72500, 0.00000], -[8509, 0.73792, 0.74891, 0.38016], -[8510, 0.74549, 0.73886, 0.36547], -[8511, 0.71737, 0.73447, 0.24335], -[8512, 0.66183, 0.80848, 0.33182], -[8513, 0.17321, 1.00000, 0.20000], -[8514, 0.50000, 0.84845, 0.11250], -[8515, 0.69261, 0.80008, 0.48165], -[8516, 1.00000, 0.24019, 0.25000], -[8517, 0.83751, 0.58552, 0.22441], -[8518, 0.86085, 0.54149, 0.20665], -[8519, 0.73313, 0.60135, 0.02966], -[8520, 0.84497, 0.63717, 0.48104], -[8521, 1.00000, 0.28349, 0.30000], -[8522, 0.75476, 0.64327, 0.12997], -[8523, 0.78754, 0.58618, 0.10422], -[8524, 0.51721, 0.81265, 0.06116], -[8525, 0.80311, 0.50000, 0.02500], -[8526, 0.34641, 1.00000, 0.47500], -[8527, 0.19486, 1.00000, 0.21250], -[8528, 0.15155, 1.00000, 0.18750], -[8529, 0.90688, 0.54391, 0.45103], -[8530, 0.51559, 0.83209, 0.09692], -[8531, 0.68565, 0.74195, 0.18354], -[8532, 0.78050, 0.57038, 0.06839], -[8533, 0.75920, 0.59217, 0.05971], -[8534, 0.70239, 0.78968, 0.43670], -[8535, 0.87500, 0.59585, 0.48125], -[8536, 0.78068, 0.70738, 0.39411], -[8537, 0.73867, 0.75774, 0.46408], -[8538, 0.93301, 0.50000, 0.47500], -[8539, 0.93301, 0.02500, 0.00000], -[8540, 0.69948, 0.74108, 0.21189], -[8541, 0.82476, 0.50000, 0.06250], -[8542, 0.81247, 0.64113, 0.27528], -[8543, 0.78612, 0.70899, 0.46698], -[8544, 1.00000, 0.08864, 0.16250], -[8545, 0.75363, 0.73608, 0.38985], -[8546, 0.78075, 0.71264, 0.43234], -[8547, 0.80961, 0.67972, 0.43259], -[8548, 0.53634, 0.77641, 0.01863], -[8549, 0.81021, 0.56931, 0.12365], -[8550, 0.57156, 0.82921, 0.17146], -[8551, 0.80511, 0.51800, 0.04631], -[8552, 0.72507, 0.71901, 0.21773], -[8553, 0.32679, 0.87500, 0.00000], -[8554, 0.87500, 0.32679, 0.00000], -[8555, 1.00000, 0.32679, 0.37500], -[8556, 0.78320, 0.69941, 0.35895], -[8557, 0.12990, 0.92500, 0.00000], -[8558, 0.30311, 1.00000, 0.32500], -[8559, 0.34641, 1.00000, 0.45000], -[8560, 0.21651, 1.00000, 0.22500], -[8561, 0.12990, 1.00000, 0.17500], -[8562, 1.00000, 0.35000, 0.50000], -[8563, 0.35000, 1.00000, 0.50000], -[8564, 1.00000, 0.00000, 0.15000], -[8565, 0.00000, 1.00000, 0.15000], -[8566, 0.74337, 0.70866, 0.23979], -[8567, 0.68150, 0.78764, 0.30557], -[8568, 0.68229, 0.78242, 0.28799], -[8569, 0.83981, 0.59536, 0.24913], -[8570, 0.52230, 0.92043, 0.44747], -[8571, 1.00000, 0.34845, 0.46250], -[8572, 0.00000, 0.97586, 0.08704], -[8573, 0.71595, 0.77107, 0.37451], -[8574, 0.55417, 0.80543, 0.09127], -[8575, 0.88652, 0.57879, 0.45539], -[8576, 0.93301, 0.50000, 0.45000], -[8577, 0.93301, 0.05000, 0.00000], -[8578, 0.75589, 0.74142, 0.45576], -[8579, 1.00000, 0.02369, 0.15000], -[8580, 0.82039, 0.54000, 0.10194], -[8581, 0.74254, 0.65356, 0.11961], -[8582, 0.77136, 0.72586, 0.46196], -[8583, 0.71651, 0.60000, 0.00000], -[8584, 0.61677, 0.80220, 0.18460], -[8585, 0.60681, 0.76101, 0.08036], -[8586, 0.74765, 0.61165, 0.06354], -[8587, 0.83400, 0.52602, 0.11095], -[8588, 0.69145, 0.78642, 0.33548], -[8589, 0.76117, 0.69152, 0.24280], -[8590, 0.70232, 0.78735, 0.39630], -[8591, 0.79031, 0.69737, 0.38511], -[8592, 0.84130, 0.61145, 0.29394], -[8593, 0.75366, 0.70447, 0.25532], -[8594, 0.63345, 0.85031, 0.50000], -[8595, 0.50000, 0.91340, 0.30000], -[8596, 0.89260, 0.52690, 0.27652], -[8597, 0.73750, 0.76184, 0.50000], -[8598, 0.58002, 0.88067, 0.38902], -[8599, 0.67095, 0.78785, 0.26878], -[8600, 0.32476, 1.00000, 0.36250], -[8601, 0.28146, 1.00000, 0.28750], -[8602, 0.04330, 1.00000, 0.15000], -[8603, 0.67662, 0.81636, 0.48404], -[8604, 0.80462, 0.66242, 0.30413], -[8605, 0.72083, 0.77787, 0.50000], -[8606, 0.65416, 0.80311, 0.27233], -[8607, 0.71174, 0.66479, 0.08020], -[8608, 0.81923, 0.60151, 0.19680], -[8609, 1.00000, 0.26184, 0.26250], -[8610, 0.57263, 0.88789, 0.40629], -[8611, 0.97685, 0.00000, 0.08655], -[8612, 0.53823, 0.87206, 0.22611], -[8613, 0.78672, 0.65864, 0.23079], -[8614, 0.64084, 0.71420, 0.04782], -[8615, 0.58445, 0.78849, 0.09757], -[8616, 0.80508, 0.64944, 0.26466], -[8617, 1.00000, 0.34845, 0.43750], -[8618, 0.88143, 0.54036, 0.26239], -[8619, 0.52039, 0.90525, 0.31258], -[8620, 0.68171, 0.70340, 0.09261], -[8621, 0.82656, 0.65656, 0.39409], -[8622, 0.77690, 0.64534, 0.17526], -[8623, 0.53906, 0.90604, 0.38136], -[8624, 0.34641, 1.00000, 0.42500], -[8625, 0.23816, 1.00000, 0.23750], -[8626, 0.10825, 1.00000, 0.16250], -[8627, 0.80000, 0.69689, 0.50000], -[8628, 0.58518, 0.85773, 0.28190], -[8629, 0.63223, 0.84133, 0.36526], -[8630, 0.67321, 0.65000, 0.00000], -[8631, 0.91136, 0.50000, 0.28750], -[8632, 0.91136, 0.21250, 0.00000], -[8633, 0.62862, 0.81591, 0.24514], -[8634, 0.71373, 0.77806, 0.39436], -[8635, 0.64672, 0.83329, 0.38398], -[8636, 0.93301, 0.50000, 0.42500], -[8637, 0.93301, 0.07500, 0.00000], -[8638, 0.85437, 0.62886, 0.47277], -[8639, 0.64408, 0.74289, 0.10063], -[8640, 0.67275, 0.77104, 0.21853], -[8641, 0.77237, 0.61646, 0.11292], -[8642, 0.84641, 0.50000, 0.10000], -[8643, 0.74132, 0.70340, 0.21329], -[8644, 0.50000, 0.93575, 0.46964], -[8645, 0.73754, 0.74735, 0.34490], -[8646, 0.62541, 0.71275, 0.02311], -[8647, 0.83683, 0.63894, 0.36561], -[8648, 0.82369, 0.58207, 0.16914], -[8649, 0.55891, 0.84947, 0.19538], -[8650, 0.70939, 0.69150, 0.11850], -[8651, 0.90552, 0.53606, 0.35987], -[8652, 1.00000, 0.06699, 0.15000], -[8653, 0.87518, 0.57491, 0.32505], -[8654, 0.60923, 0.86742, 0.44057], -[8655, 0.83018, 0.61411, 0.25347], -[8656, 0.72289, 0.74090, 0.26415], -[8657, 0.86099, 0.55790, 0.22688], -[8658, 0.62573, 0.82633, 0.27017], -[8659, 0.70455, 0.65166, 0.04582], -[8660, 0.81001, 0.59311, 0.15437], -[8661, 0.58138, 0.88844, 0.48283], -[8662, 0.60825, 0.71250, 0.00000], -[8663, 0.56389, 0.89674, 0.42428], -[8664, 0.50000, 0.89175, 0.21250], -[8665, 0.85529, 0.61609, 0.37046], -[8666, 0.75905, 0.66410, 0.16728], -[8667, 0.68952, 0.79898, 0.38119], -[8668, 0.73977, 0.69677, 0.19136], -[8669, 0.84577, 0.64106, 0.45842], -[8670, 0.52850, 0.80135, 0.04551], -[8671, 0.76017, 0.73657, 0.41227], -[8672, 0.75641, 0.71803, 0.29894], -[8673, 0.76645, 0.54802, 0.00970], -[8674, 0.51747, 0.92509, 0.43216], -[8675, 0.64275, 0.70081, 0.02679], -[8676, 0.81929, 0.66340, 0.37017], -[8677, 0.50000, 0.93505, 0.43750], -[8678, 0.81605, 0.67817, 0.45095], -[8679, 1.00000, 0.30514, 0.31250], -[8680, 0.77252, 0.55938, 0.03239], -[8681, 1.00000, 0.17524, 0.18750], -[8682, 0.56338, 0.89243, 0.37927], -[8683, 0.70380, 0.75195, 0.23985], -[8684, 0.73486, 0.74069, 0.30043], -[8685, 0.71530, 0.73510, 0.22336], -[8686, 0.58034, 0.81101, 0.13389], -[8687, 0.89108, 0.57238, 0.41656], -[8688, 0.73160, 0.76862, 0.44831], -[8689, 0.67358, 0.74207, 0.14732], -[8690, 1.00000, 0.19689, 0.20000], -[8691, 0.92285, 0.52615, 0.48319], -[8692, 0.62531, 0.75332, 0.08733], -[8693, 0.80988, 0.53922, 0.07315], -[8694, 0.75512, 0.68688, 0.20529], -[8695, 0.93207, 0.50970, 0.48168], -[8696, 0.78683, 0.61406, 0.13549], -[8697, 1.00000, 0.34845, 0.41250], -[8698, 0.79300, 0.64623, 0.21252], -[8699, 0.87468, 0.60142, 0.45144], -[8700, 0.15359, 0.92500, 0.00000], -[8701, 1.00000, 0.15359, 0.17500], -[8702, 0.67492, 0.81360, 0.39123], -[8703, 1.00000, 0.32679, 0.35000], -[8704, 0.77089, 0.72840, 0.43265], -[8705, 0.02165, 0.93750, 0.00000], -[8706, 0.58192, 0.88822, 0.45701], -[8707, 0.56776, 0.81581, 0.12381], -[8708, 0.66711, 0.82654, 0.46427], -[8709, 0.50000, 0.87010, 0.15000], -[8710, 0.51713, 0.91864, 0.36468], -[8711, 0.83492, 0.58887, 0.20708], -[8712, 0.62831, 0.85558, 0.44541], -[8713, 0.75981, 0.55000, 0.00000], -[8714, 0.92500, 0.52369, 0.50000], -[8715, 0.34641, 1.00000, 0.40000], -[8716, 0.25981, 1.00000, 0.25000], -[8717, 0.08660, 1.00000, 0.15000], -[8718, 0.91250, 0.54534, 0.50000], -[8719, 0.96964, 0.00000, 0.06425], -[8720, 0.92253, 0.52277, 0.42345], -[8721, 0.75697, 0.72645, 0.32824], -[8722, 0.85347, 0.58917, 0.26580], -[8723, 0.72176, 0.62113, 0.02708], -[8724, 0.21854, 0.91250, 0.00000], -[8725, 1.00000, 0.21854, 0.21250], -[8726, 0.57413, 0.74961, 0.01122], -[8727, 0.62737, 0.85826, 0.48406], -[8728, 0.91736, 0.51732, 0.35401], -[8729, 0.93301, 0.50000, 0.40000], -[8730, 0.93301, 0.10000, 0.00000], -[8731, 0.76058, 0.57914, 0.03451], -[8732, 0.30514, 0.88750, 0.00000], -[8733, 0.88750, 0.30514, 0.00000], -[8734, 0.52519, 0.86308, 0.16815], -[8735, 0.82368, 0.67201, 0.47172], -[8736, 0.59134, 0.88175, 0.43918], -[8737, 0.61737, 0.77008, 0.10408], -[8738, 1.00000, 0.28349, 0.27500], -[8739, 0.79556, 0.66628, 0.26724], -[8740, 0.78227, 0.69289, 0.30235], -[8741, 0.72930, 0.77342, 0.46698], -[8742, 0.79627, 0.54869, 0.05714], -[8743, 0.84990, 0.62062, 0.34571], -[8744, 1.00000, 0.13194, 0.16250], -[8745, 0.71158, 0.76908, 0.31685], -[8746, 0.53875, 0.84325, 0.13935], -[8747, 0.73511, 0.67262, 0.12772], -[8748, 0.80883, 0.68106, 0.38443], -[8749, 0.90000, 0.56699, 0.50000], -[8750, 0.78428, 0.67313, 0.24844], -[8751, 0.66484, 0.77378, 0.19872], -[8752, 0.74105, 0.64459, 0.09143], -[8753, 0.88971, 0.50000, 0.20000], -[8754, 0.69019, 0.77538, 0.26761], -[8755, 0.91551, 0.51343, 0.32730], -[8756, 0.65409, 0.83508, 0.41976], -[8757, 0.56442, 0.90123, 0.46901], -[8758, 0.52015, 0.92224, 0.39655], -[8759, 0.67674, 0.81609, 0.41144], -[8760, 0.30311, 1.00000, 0.30000], -[8761, 0.32476, 1.00000, 0.33750], -[8762, 0.02165, 1.00000, 0.13750], -[8763, 0.51404, 0.85215, 0.12374], -[8764, 0.83491, 0.62461, 0.28843], -[8765, 0.50000, 0.93505, 0.41250], -[8766, 0.62043, 0.83666, 0.28308], -[8767, 0.89397, 0.56017, 0.36200], -[8768, 0.53226, 0.92113, 0.48358], -[8769, 0.75537, 0.63993, 0.11003], -[8770, 0.82264, 0.57532, 0.14722], -[8771, 0.52187, 0.82474, 0.07609], -[8772, 0.74048, 0.67895, 0.14913], -[8773, 0.79758, 0.69009, 0.35802], -[8774, 0.87329, 0.60050, 0.40244], -[8775, 0.88836, 0.55993, 0.32658], -[8776, 0.65797, 0.76527, 0.16204], -[8777, 0.80642, 0.53380, 0.05554], -[8778, 0.52384, 0.79492, 0.02396], -[8779, 0.59375, 0.79612, 0.11713], -[8780, 0.06495, 0.93750, 0.00000], -[8781, 0.79900, 0.60214, 0.13645], -[8782, 1.00000, 0.24019, 0.22500], -[8783, 0.66247, 0.73836, 0.11361], -[8784, 0.64326, 0.82559, 0.30504], -[8785, 0.69958, 0.79803, 0.41550], -[8786, 0.61605, 0.85756, 0.36384], -[8787, 1.00000, 0.04534, 0.13750], -[8788, 0.82439, 0.67089, 0.43859], -[8789, 0.76374, 0.70757, 0.27744], -[8790, 0.72082, 0.78025, 0.42676], -[8791, 0.76223, 0.73989, 0.42702], -[8792, 0.78871, 0.69452, 0.32871], -[8793, 0.64118, 0.83582, 0.34485], -[8794, 0.79632, 0.63628, 0.19209], -[8795, 0.64775, 0.75482, 0.11990], -[8796, 0.73724, 0.63211, 0.06322], -[8797, 0.92845, 0.52001, 0.46198], -[8798, 0.89933, 0.54792, 0.34198], -[8799, 0.56068, 0.84296, 0.16977], -[8800, 0.76534, 0.60830, 0.07779], -[8801, 0.86737, 0.61275, 0.42086], -[8802, 1.00000, 0.34845, 0.38750], -[8803, 0.51739, 0.88680, 0.21722], -[8804, 0.67286, 0.78492, 0.24455], -[8805, 0.88750, 0.58864, 0.50000], -[8806, 0.86851, 0.52354, 0.17478], -[8807, 0.67163, 0.82379, 0.43284], -[8808, 0.86493, 0.61039, 0.38351], -[8809, 0.75009, 0.66490, 0.13993], -[8810, 0.66534, 0.82244, 0.37604], -[8811, 0.63389, 0.84882, 0.38972], -[8812, 1.00000, 0.11029, 0.15000], -[8813, 0.58401, 0.88779, 0.42624], -[8814, 0.91317, 0.54471, 0.43550], -[8815, 0.58640, 0.82026, 0.15639], -[8816, 0.55040, 0.87702, 0.24939], -[8817, 0.50000, 0.91340, 0.27500], -[8818, 0.86806, 0.50000, 0.13750], -[8819, 0.58477, 0.84075, 0.20650], -[8820, 0.67534, 0.72235, 0.10333], -[8821, 0.64062, 0.82135, 0.27571], -[8822, 0.63373, 0.80405, 0.20463], -[8823, 0.78150, 0.71376, 0.37608], -[8824, 0.34641, 1.00000, 0.37500], -[8825, 0.28146, 1.00000, 0.26250], -[8826, 0.19486, 1.00000, 0.18750], -[8827, 0.17321, 1.00000, 0.17500], -[8828, 0.06495, 1.00000, 0.13750], -[8829, 0.64474, 0.84828, 0.47732], -[8830, 0.69982, 0.71847, 0.13966], -[8831, 0.60115, 0.84904, 0.26849], -[8832, 0.88111, 0.59469, 0.42322], -[8833, 0.79593, 0.67835, 0.29405], -[8834, 0.50000, 0.82679, 0.05000], -[8835, 0.93301, 0.50000, 0.37500], -[8836, 0.93301, 0.12500, 0.00000], -[8837, 0.81250, 0.68967, 0.48125], -[8838, 0.89472, 0.54735, 0.30984], -[8839, 0.91900, 0.53918, 0.46827], -[8840, 0.64241, 0.77177, 0.14228], -[8841, 0.63662, 0.79188, 0.17762], -[8842, 0.78930, 0.54597, 0.03605], -[8843, 0.76602, 0.73008, 0.37147], -[8844, 0.77217, 0.71238, 0.31945], -[8845, 0.61350, 0.78508, 0.12103], -[8846, 0.65096, 0.82619, 0.32666], -[8847, 0.78750, 0.71854, 0.50000], -[8848, 0.63172, 0.77114, 0.12197], -[8849, 0.70708, 0.78759, 0.37176], -[8850, 0.77204, 0.68088, 0.22232], -[8851, 0.72572, 0.69150, 0.13681], -[8852, 0.84312, 0.64885, 0.42995], -[8853, 0.62990, 0.70000, 0.00000], -[8854, 0.78125, 0.60305, 0.09656], -[8855, 0.55000, 0.91340, 0.50000], -[8856, 0.21651, 1.00000, 0.20000], -[8857, 0.15155, 1.00000, 0.16250], -[8858, 0.64639, 0.73005, 0.06859], -[8859, 0.74883, 0.72479, 0.27449], -[8860, 0.50000, 0.93505, 0.38750], -[8861, 0.91136, 0.50000, 0.26250], -[8862, 0.91136, 0.23750, 0.00000], -[8863, 0.88295, 0.58704, 0.38656], -[8864, 0.77547, 0.72648, 0.41079], -[8865, 0.56102, 0.90540, 0.44745], -[8866, 0.90593, 0.53224, 0.31726], -[8867, 0.92137, 0.52793, 0.40110], -[8868, 1.00000, 0.32679, 0.32500], -[8869, 0.65958, 0.70211, 0.04235], -[8870, 1.00000, 0.26184, 0.23750], -[8871, 0.59344, 0.86664, 0.31480], -[8872, 0.36922, 1.00000, 0.46458], -[8873, 1.00000, 0.37010, 0.47500], -[8874, 0.60864, 0.87212, 0.41810], -[8875, 0.54737, 0.91285, 0.42967], -[8876, 0.87500, 0.61029, 0.50000], -[8877, 0.54408, 0.86671, 0.19853], -[8878, 0.72995, 0.66387, 0.09416], -[8879, 1.00000, 0.30514, 0.28750], -[8880, 0.82930, 0.55936, 0.12879], -[8881, 0.87893, 0.55656, 0.26292], -[8882, 0.84584, 0.56478, 0.17736], -[8883, 0.76820, 0.74045, 0.47941], -[8884, 0.55579, 0.86564, 0.21612], -[8885, 0.88758, 0.57467, 0.35581], -[8886, 0.92779, 0.52386, 0.43956], -[8887, 0.47835, 0.81250, 0.00000], -[8888, 0.81250, 0.47835, 0.00000], -[8889, 0.70461, 0.73265, 0.17465], -[8890, 0.64746, 0.84723, 0.45355], -[8891, 0.60119, 0.77659, 0.08206], -[8892, 0.45670, 0.82500, 0.00000], -[8893, 0.82500, 0.45670, 0.00000], -[8894, 0.69486, 0.63750, 0.00000], -[8895, 0.72397, 0.75538, 0.28901], -[8896, 1.00000, 0.08864, 0.13750], -[8897, 0.86491, 0.51998, 0.15238], -[8898, 0.61862, 0.73099, 0.02852], -[8899, 0.36806, 1.00000, 0.43750], -[8900, 0.23816, 1.00000, 0.21250], -[8901, 0.12990, 1.00000, 0.15000], -[8902, 0.91611, 0.53447, 0.37972], -[8903, 0.67595, 0.82613, 0.50000], -[8904, 1.00000, 0.37010, 0.45000], -[8905, 0.73408, 0.76754, 0.39270], -[8906, 0.59778, 0.73929, 0.01459], -[8907, 0.81419, 0.66835, 0.32700], -[8908, 0.86022, 0.60035, 0.30210], -[8909, 0.55681, 0.89218, 0.31677], -[8910, 0.57156, 0.89035, 0.35768], -[8911, 0.85260, 0.58884, 0.24305], -[8912, 0.86669, 0.56944, 0.24643], -[8913, 0.90817, 0.55997, 0.46265], -[8914, 0.71713, 0.77702, 0.35273], -[8915, 0.75901, 0.68065, 0.18319], -[8916, 0.57651, 0.80995, 0.11088], -[8917, 0.65675, 0.79997, 0.23810], -[8918, 0.56071, 0.79817, 0.06594], -[8919, 0.69921, 0.78512, 0.31389], -[8920, 0.87620, 0.52867, 0.19547], -[8921, 0.80000, 0.50000, 0.00000], -[8922, 0.50000, 0.80000, 0.00000], -[8923, 0.50000, 0.84845, 0.08750], -[8924, 0.73816, 0.58750, 0.00000], -[8925, 0.55172, 0.82545, 0.10719], -[8926, 0.86637, 0.60461, 0.34533], -[8927, 0.78165, 0.69357, 0.28067], -[8928, 0.73017, 0.65246, 0.07423], -[8929, 0.60608, 0.87289, 0.39530], -[8930, 1.00000, 0.34845, 0.36250], -[8931, 0.28349, 0.90000, 0.00000], -[8932, 0.90000, 0.28349, 0.00000], -[8933, 0.58750, 0.89175, 0.50000], -[8934, 0.87291, 0.61485, 0.47981], -[8935, 0.67940, 0.81242, 0.36269], -[8936, 0.79149, 0.60490, 0.11514], -[8937, 0.10825, 0.93750, 0.00000], -[8938, 0.32476, 1.00000, 0.31250], -[8939, 1.00000, 0.37500, 0.50000], -[8940, 0.37500, 1.00000, 0.50000], -[8941, 1.00000, 0.00000, 0.12500], -[8942, 0.00000, 1.00000, 0.12500], -[8943, 0.43505, 0.83750, 0.00000], -[8944, 0.83750, 0.43505, 0.00000], -[8945, 0.67481, 0.71160, 0.07695], -[8946, 0.54972, 0.90521, 0.36179], -[8947, 0.67593, 0.69903, 0.05819], -[8948, 0.80358, 0.59104, 0.11833], -[8949, 0.83389, 0.66238, 0.41759], -[8950, 0.60351, 0.88042, 0.45861], -[8951, 0.82378, 0.61710, 0.21418], -[8952, 0.62224, 0.83796, 0.27241], -[8953, 1.00000, 0.02369, 0.12500], -[8954, 0.81906, 0.52461, 0.05825], -[8955, 0.67621, 0.68666, 0.03884], -[8956, 0.69565, 0.65755, 0.02548], -[8957, 0.75214, 0.60500, 0.04202], -[8958, 0.78937, 0.71365, 0.40388], -[8959, 0.71617, 0.75280, 0.25087], -[8960, 0.82765, 0.65626, 0.33856], -[8961, 0.86371, 0.54397, 0.18402], -[8962, 0.72538, 0.64371, 0.05131], -[8963, 0.90298, 0.51056, 0.24327], -[8964, 0.86733, 0.58638, 0.28535], -[8965, 0.64043, 0.85240, 0.42617], -[8966, 0.58662, 0.85959, 0.25659], -[8967, 0.52165, 0.78750, 0.00000], -[8968, 0.74675, 0.68919, 0.16870], -[8969, 0.65729, 0.84284, 0.50000], -[8970, 0.62278, 0.84747, 0.30922], -[8971, 0.55657, 0.83234, 0.12592], -[8972, 0.34641, 1.00000, 0.35000], -[8973, 0.30311, 1.00000, 0.27500], -[8974, 0.04330, 1.00000, 0.12500], -[8975, 1.00000, 0.37010, 0.42500], -[8976, 0.66643, 0.81435, 0.31173], -[8977, 0.84517, 0.53615, 0.12443], -[8978, 0.54423, 0.85447, 0.15862], -[8979, 0.50000, 0.89175, 0.18750], -[8980, 1.00000, 0.28349, 0.25000], -[8981, 0.74358, 0.76320, 0.41315], -[8982, 0.93301, 0.50000, 0.35000], -[8983, 0.93301, 0.15000, 0.00000], -[8984, 0.25981, 1.00000, 0.22500], -[8985, 0.36806, 1.00000, 0.41250], -[8986, 0.10825, 1.00000, 0.13750], -[8987, 0.79881, 0.53473, 0.03191], -[8988, 0.50000, 0.93505, 0.36250], -[8989, 0.86250, 0.63194, 0.50000], -[8990, 0.80702, 0.69729, 0.42379], -[8991, 0.74579, 0.74483, 0.32020], -[8992, 0.41340, 0.85000, 0.00000], -[8993, 0.85000, 0.41340, 0.00000], -[8994, 0.78612, 0.65682, 0.19334], -[8995, 0.56240, 0.77173, 0.01877], -[8996, 0.52444, 0.90450, 0.27574], -[8997, 0.81507, 0.60876, 0.17018], -[8998, 0.77980, 0.72459, 0.39684], -[8999, 0.63111, 0.74712, 0.06710], -[9000, 0.77746, 0.71994, 0.35434], -[9001, 0.65301, 0.79796, 0.21553], -[9002, 0.82476, 0.50000, 0.03750], -[9003, 0.78806, 0.59037, 0.08219], -[9004, 0.54513, 0.79266, 0.03227], -[9005, 0.58980, 0.75683, 0.02707], -[9006, 0.19689, 0.92500, 0.00000], -[9007, 1.00000, 0.19689, 0.17500], -[9008, 0.84268, 0.64045, 0.34474], -[9009, 0.53904, 0.89295, 0.26229], -[9010, 1.00000, 0.17524, 0.16250], -[9011, 0.87107, 0.61979, 0.45820], -[9012, 0.70267, 0.72799, 0.15217], -[9013, 0.66619, 0.82295, 0.34615], -[9014, 0.73428, 0.76585, 0.36131], -[9015, 0.53155, 0.89018, 0.23543], -[9016, 0.78623, 0.68725, 0.26644], -[9017, 0.51208, 0.93861, 0.45673], -[9018, 1.00000, 0.06699, 0.12500], -[9019, 0.90346, 0.53536, 0.29433], -[9020, 0.84238, 0.60588, 0.23808], -[9021, 0.65697, 0.78127, 0.17849], -[9022, 0.83867, 0.63644, 0.30775], -[9023, 1.00000, 0.21854, 0.18750], -[9024, 0.85865, 0.63345, 0.41639], -[9025, 0.78038, 0.53542, 0.00000], -[9026, 0.54330, 0.77500, 0.00000], -[9027, 0.83557, 0.65414, 0.35946], -[9028, 0.91316, 0.54903, 0.39723], -[9029, 0.68763, 0.76448, 0.20233], -[9030, 0.54951, 0.91849, 0.48023], -[9031, 1.00000, 0.15359, 0.15000], -[9032, 0.74462, 0.75880, 0.37396], -[9033, 0.69485, 0.80846, 0.40142], -[9034, 0.80342, 0.66061, 0.24642], -[9035, 0.71119, 0.76617, 0.26887], -[9036, 0.81136, 0.66620, 0.28967], -[9037, 0.56702, 0.90818, 0.48908], -[9038, 0.89278, 0.53088, 0.24007], -[9039, 0.82473, 0.65756, 0.31584], -[9040, 0.76794, 0.62535, 0.09295], -[9041, 0.69153, 0.81472, 0.43284], -[9042, 0.92896, 0.52021, 0.38629], -[9043, 0.84940, 0.62844, 0.32640], -[9044, 0.80688, 0.67934, 0.31544], -[9045, 0.74715, 0.76417, 0.43273], -[9046, 0.60962, 0.85676, 0.29737], -[9047, 0.50000, 0.91340, 0.25000], -[9048, 1.00000, 0.32679, 0.30000], -[9049, 1.00000, 0.37010, 0.40000], -[9050, 0.84641, 0.50000, 0.07500], -[9051, 0.79424, 0.62758, 0.15019], -[9052, 0.92165, 0.54539, 0.48575], -[9053, 0.83178, 0.63656, 0.27626], -[9054, 0.52720, 0.86219, 0.14529], -[9055, 0.61787, 0.84137, 0.26022], -[9056, 0.65155, 0.68750, 0.00000], -[9057, 0.68700, 0.82027, 0.45112], -[9058, 0.88971, 0.50000, 0.17500], -[9059, 0.39175, 0.86250, 0.00000], -[9060, 0.86250, 0.39175, 0.00000], -[9061, 0.70160, 0.70470, 0.10174], -[9062, 0.59997, 0.87788, 0.37023], -[9063, 0.81152, 0.56663, 0.09030], -[9064, 0.60228, 0.76077, 0.04594], -[9065, 0.50000, 0.87010, 0.12500], -[9066, 1.00000, 0.24019, 0.20000], -[9067, 0.62500, 0.87010, 0.50000], -[9068, 0.73774, 0.73433, 0.24651], -[9069, 0.62944, 0.86211, 0.40850], -[9070, 0.52065, 0.90320, 0.25313], -[9071, 1.00000, 0.34845, 0.33750], -[9072, 0.69102, 0.74550, 0.16150], -[9073, 0.80553, 0.69901, 0.39777], -[9074, 0.80906, 0.62261, 0.17484], -[9075, 0.90616, 0.56864, 0.44073], -[9076, 0.36806, 1.00000, 0.38750], -[9077, 0.28146, 1.00000, 0.23750], -[9078, 0.08660, 1.00000, 0.12500], -[9079, 0.85492, 0.53850, 0.14319], -[9080, 0.71420, 0.64277, 0.02571], -[9081, 0.63674, 0.86131, 0.46520], -[9082, 0.77500, 0.74019, 0.50000], -[9083, 0.73519, 0.71852, 0.19712], -[9084, 0.88272, 0.57177, 0.29411], -[9085, 0.72462, 0.78806, 0.45081], -[9086, 0.82982, 0.63197, 0.25384], -[9087, 0.89520, 0.57637, 0.37737], -[9088, 0.72371, 0.77331, 0.33610], -[9089, 0.82213, 0.67071, 0.34859], -[9090, 0.58356, 0.77338, 0.04172], -[9091, 0.88880, 0.59823, 0.46926], -[9092, 1.00000, 0.13194, 0.13750], -[9093, 0.86616, 0.62836, 0.43748], -[9094, 0.80065, 0.58909, 0.09879], -[9095, 0.77525, 0.67629, 0.19883], -[9096, 0.53570, 0.90667, 0.29960], -[9097, 0.81389, 0.63738, 0.21609], -[9098, 0.70177, 0.77051, 0.24838], -[9099, 0.91136, 0.50000, 0.23750], -[9100, 0.91136, 0.26250, 0.00000], -[9101, 1.00000, 0.30514, 0.26250], -[9102, 0.85559, 0.63742, 0.39399], -[9103, 0.70535, 0.80612, 0.45245], -[9104, 0.67533, 0.76757, 0.17689], -[9105, 0.85000, 0.65359, 0.50000], -[9106, 0.54671, 0.92112, 0.45128], -[9107, 0.67664, 0.80453, 0.28872], -[9108, 0.52997, 0.87545, 0.17983], -[9109, 0.61028, 0.82412, 0.18652], -[9110, 0.56047, 0.84332, 0.14681], -[9111, 0.72051, 0.71151, 0.14680], -[9112, 0.51123, 0.80880, 0.01561], -[9113, 0.57834, 0.85668, 0.21396], -[9114, 0.75938, 0.74760, 0.37898], -[9115, 0.57306, 0.87660, 0.26890], -[9116, 0.74496, 0.60201, 0.01741], -[9117, 0.71845, 0.68358, 0.09156], -[9118, 0.71381, 0.70736, 0.12523], -[9119, 0.57393, 0.86784, 0.23964], -[9120, 0.69901, 0.69713, 0.08062], -[9121, 0.83468, 0.51850, 0.06989], -[9122, 0.56495, 0.76250, 0.00000], -[9123, 0.32476, 1.00000, 0.28750], -[9124, 0.34641, 1.00000, 0.32500], -[9125, 0.02165, 1.00000, 0.11250], -[9126, 0.61391, 0.81321, 0.16466], -[9127, 0.50000, 0.93505, 0.33750], -[9128, 0.72167, 0.79311, 0.46890], -[9129, 0.55755, 0.90200, 0.33751], -[9130, 0.81985, 0.68512, 0.40337], -[9131, 0.61286, 0.86340, 0.32692], -[9132, 0.85734, 0.60557, 0.27794], -[9133, 0.93301, 0.50000, 0.32500], -[9134, 0.93301, 0.17500, 0.00000], -[9135, 0.75445, 0.75013, 0.36099], -[9136, 0.26184, 0.91250, 0.00000], -[9137, 1.00000, 0.26184, 0.21250], -[9138, 0.75694, 0.58384, 0.01274], -[9139, 0.56445, 0.79074, 0.04453], -[9140, 0.64681, 0.78498, 0.15823], -[9141, 0.83660, 0.53142, 0.08878], -[9142, 0.77477, 0.70189, 0.25812], -[9143, 0.71343, 0.78311, 0.32888], -[9144, 0.89698, 0.58868, 0.47809], -[9145, 0.57933, 0.87786, 0.28704], -[9146, 0.51641, 0.81781, 0.03500], -[9147, 0.19486, 1.00000, 0.16250], -[9148, 0.53289, 0.92771, 0.41471], -[9149, 0.85440, 0.61983, 0.30571], -[9150, 0.91209, 0.56029, 0.42188], -[9151, 0.61570, 0.82922, 0.20796], -[9152, 0.63277, 0.84987, 0.32876], -[9153, 0.62285, 0.83399, 0.23811], -[9154, 0.38924, 1.00000, 0.47613], -[9155, 1.00000, 0.04534, 0.11250], -[9156, 0.72353, 0.72701, 0.18350], -[9157, 0.90390, 0.57004, 0.39766], -[9158, 0.21651, 1.00000, 0.17500], -[9159, 0.17321, 1.00000, 0.15000], -[9160, 0.50000, 0.95000, 0.50000], -[9161, 0.95000, 0.50000, 0.50000], -[9162, 0.95000, 0.00000, 0.00000], -[9163, 0.00000, 0.95000, 0.00000], -[9164, 0.89466, 0.57086, 0.33809], -[9165, 0.88377, 0.55512, 0.24824], -[9166, 0.37010, 0.87500, 0.00000], -[9167, 0.87500, 0.37010, 0.00000], -[9168, 1.00000, 0.37010, 0.37500], -[9169, 0.77794, 0.71100, 0.29516], -[9170, 0.51875, 0.87731, 0.16250], -[9171, 0.51522, 0.92901, 0.34425], -[9172, 1.00000, 0.11029, 0.12500], -[9173, 0.81174, 0.51733, 0.02434], -[9174, 0.60053, 0.82745, 0.17184], -[9175, 0.69519, 0.77020, 0.22318], -[9176, 0.51787, 0.94055, 0.47937], -[9177, 0.66420, 0.73797, 0.09071], -[9178, 0.70851, 0.79287, 0.34947], -[9179, 0.60823, 0.80937, 0.14181], -[9180, 0.81719, 0.64752, 0.24261], -[9181, 0.71882, 0.66456, 0.05835], -[9182, 0.60726, 0.79020, 0.09953], -[9183, 0.79919, 0.71457, 0.43459], -[9184, 0.86806, 0.50000, 0.11250], -[9185, 0.72833, 0.68614, 0.10958], -[9186, 0.74481, 0.73775, 0.26598], -[9187, 0.58110, 0.78925, 0.06028], -[9188, 0.71651, 0.62500, 0.00000], -[9189, 0.74925, 0.72749, 0.24815], -[9190, 0.63966, 0.76542, 0.10119], -[9191, 0.85178, 0.55715, 0.15622], -[9192, 0.54331, 0.91781, 0.37069], -[9193, 0.04330, 0.95000, 0.00000], -[9194, 0.36806, 1.00000, 0.36250], -[9195, 0.38971, 1.00000, 0.45000], -[9196, 0.30311, 1.00000, 0.25000], -[9197, 0.23816, 1.00000, 0.18750], -[9198, 0.15155, 1.00000, 0.13750], -[9199, 0.06495, 1.00000, 0.11250], -[9200, 0.87543, 0.57475, 0.25977], -[9201, 0.84871, 0.65842, 0.47316], -[9202, 0.62216, 0.74928, 0.04606], -[9203, 0.83131, 0.64728, 0.28889], -[9204, 0.81031, 0.61266, 0.14965], -[9205, 0.90497, 0.52705, 0.25910], -[9206, 0.68818, 0.80576, 0.32104], -[9207, 0.55334, 0.86318, 0.17782], -[9208, 0.85070, 0.58726, 0.20569], -[9209, 0.53304, 0.93261, 0.46374], -[9210, 0.69032, 0.73976, 0.13732], -[9211, 0.59550, 0.88993, 0.40647], -[9212, 0.53698, 0.83574, 0.08942], -[9213, 0.81380, 0.70052, 0.45051], -[9214, 0.69191, 0.80773, 0.34400], -[9215, 0.53064, 0.91931, 0.33028], -[9216, 0.55007, 0.81899, 0.07299], -[9217, 0.70487, 0.78243, 0.28380], -[9218, 1.00000, 0.39312, 0.46458], -[9219, 0.63287, 0.83314, 0.25256], -[9220, 0.71250, 0.80514, 0.50000], -[9221, 0.59976, 0.86663, 0.28748], -[9222, 1.00000, 0.28349, 0.22500], -[9223, 0.66785, 0.84101, 0.44699], -[9224, 0.57828, 0.89997, 0.39136], -[9225, 0.63741, 0.83901, 0.28550], -[9226, 0.86255, 0.52195, 0.12608], -[9227, 0.75921, 0.65962, 0.11948], -[9228, 0.77537, 0.65902, 0.15230], -[9229, 0.78188, 0.59458, 0.06234], -[9230, 0.88852, 0.53409, 0.21407], -[9231, 0.64194, 0.81799, 0.22559], -[9232, 1.00000, 0.34845, 0.31250], -[9233, 0.58660, 0.75000, 0.00000], -[9234, 0.78458, 0.73122, 0.42026], -[9235, 0.75975, 0.76071, 0.47269], -[9236, 0.70871, 0.68330, 0.06695], -[9237, 0.68440, 0.67638, 0.01955], -[9238, 0.56317, 0.88933, 0.27935], -[9239, 0.84162, 0.60612, 0.21513], -[9240, 0.52306, 0.91942, 0.30523], -[9241, 0.53036, 0.93575, 0.50000], -[9242, 0.74635, 0.77442, 0.48533], -[9243, 0.80713, 0.69083, 0.33113], -[9244, 0.83750, 0.67524, 0.50000], -[9245, 1.00000, 0.39175, 0.43750], -[9246, 0.92850, 0.54124, 0.45135], -[9247, 0.80956, 0.70806, 0.47389], -[9248, 1.00000, 0.32679, 0.27500], -[9249, 0.38971, 1.00000, 0.42500], -[9250, 0.25981, 1.00000, 0.20000], -[9251, 0.12990, 1.00000, 0.12500], -[9252, 0.69339, 0.82215, 0.46946], -[9253, 0.61651, 0.85334, 0.27762], -[9254, 0.75981, 0.57500, 0.00000], -[9255, 0.84275, 0.57528, 0.15830], -[9256, 1.00000, 0.08864, 0.11250], -[9257, 0.55890, 0.91520, 0.40998], -[9258, 0.91130, 0.52831, 0.27964], -[9259, 0.84823, 0.61919, 0.26492], -[9260, 0.65003, 0.85246, 0.40531], -[9261, 0.73520, 0.76537, 0.32129], -[9262, 0.73318, 0.63797, 0.03772], -[9263, 0.84261, 0.65839, 0.37802], -[9264, 0.77921, 0.64744, 0.13658], -[9265, 0.69925, 0.72319, 0.11719], -[9266, 0.82893, 0.63163, 0.23090], -[9267, 0.89482, 0.56648, 0.30787], -[9268, 0.65258, 0.79885, 0.19259], -[9269, 0.77361, 0.57095, 0.01611], -[9270, 0.78969, 0.55259, 0.02071], -[9271, 0.78757, 0.73190, 0.44763], -[9272, 0.96458, 0.00000, 0.02221], -[9273, 0.00000, 0.96458, 0.02221], -[9274, 0.74400, 0.74673, 0.28182], -[9275, 0.67321, 0.67500, 0.00000], -[9276, 0.89897, 0.55475, 0.29239], -[9277, 0.34845, 0.88750, 0.00000], -[9278, 0.88750, 0.34845, 0.00000], -[9279, 0.79045, 0.73047, 0.47387], -[9280, 0.50000, 0.89175, 0.16250], -[9281, 0.86866, 0.63602, 0.48972], -[9282, 0.97500, 0.00000, 0.04330], -[9283, 0.00000, 0.97500, 0.04330], -[9284, 0.50000, 0.82679, 0.02500], -[9285, 0.86583, 0.56776, 0.20463], -[9286, 0.59468, 0.88471, 0.34866], -[9287, 0.53240, 0.88644, 0.19984], -[9288, 0.82493, 0.65651, 0.28116], -[9289, 0.62001, 0.86692, 0.34683], -[9290, 0.50000, 0.93505, 0.31250], -[9291, 1.00000, 0.37010, 0.35000], -[9292, 0.17524, 0.93750, 0.00000], -[9293, 0.61808, 0.76533, 0.06197], -[9294, 0.58680, 0.89349, 0.36972], -[9295, 0.54364, 0.92335, 0.39244], -[9296, 0.56287, 0.91223, 0.39574], -[9297, 0.50000, 0.91340, 0.22500], -[9298, 0.75830, 0.75675, 0.38942], -[9299, 0.92666, 0.53281, 0.36818], -[9300, 0.08660, 0.95000, 0.00000], -[9301, 0.34641, 1.00000, 0.30000], -[9302, 1.00000, 0.40000, 0.50000], -[9303, 0.40000, 1.00000, 0.50000], -[9304, 1.00000, 0.00000, 0.10000], -[9305, 0.00000, 1.00000, 0.10000], -[9306, 0.67474, 0.82859, 0.36517], -[9307, 0.79309, 0.66916, 0.21141], -[9308, 0.88752, 0.51935, 0.17946], -[9309, 0.69747, 0.67493, 0.03288], -[9310, 0.55020, 0.80836, 0.04825], -[9311, 0.55752, 0.89953, 0.29914], -[9312, 0.90281, 0.54261, 0.27435], -[9313, 0.62871, 0.87190, 0.42926], -[9314, 0.93301, 0.50000, 0.30000], -[9315, 0.93301, 0.20000, 0.00000], -[9316, 0.75664, 0.74028, 0.29994], -[9317, 0.77398, 0.74210, 0.39610], -[9318, 1.00000, 0.02369, 0.10000], -[9319, 0.59485, 0.85827, 0.23519], -[9320, 0.80641, 0.70244, 0.36978], -[9321, 0.75133, 0.70731, 0.19029], -[9322, 0.79002, 0.72562, 0.39971], -[9323, 0.74171, 0.75579, 0.30121], -[9324, 1.00000, 0.39175, 0.41250], -[9325, 0.95389, 0.50000, 0.46458], -[9326, 0.95389, 0.03542, 0.00000], -[9327, 0.77268, 0.59476, 0.04130], -[9328, 0.77881, 0.67095, 0.17678], -[9329, 0.76135, 0.62920, 0.06915], -[9330, 0.68917, 0.78967, 0.24966], -[9331, 0.50000, 0.84845, 0.06250], -[9332, 1.00000, 0.19689, 0.15000], -[9333, 0.87755, 0.60354, 0.33565], -[9334, 0.52614, 0.85197, 0.10152], -[9335, 0.62600, 0.87638, 0.46053], -[9336, 0.86496, 0.64234, 0.47097], -[9337, 0.77379, 0.64077, 0.10976], -[9338, 0.65506, 0.82091, 0.25785], -[9339, 1.00000, 0.21854, 0.16250], -[9340, 0.51587, 0.94278, 0.41798], -[9341, 0.76250, 0.76184, 0.50000], -[9342, 0.36806, 1.00000, 0.33750], -[9343, 0.28146, 1.00000, 0.21250], -[9344, 0.32476, 1.00000, 0.26250], -[9345, 0.10825, 1.00000, 0.11250], -[9346, 0.04330, 1.00000, 0.10000], -[9347, 1.00000, 0.30514, 0.23750], -[9348, 0.82706, 0.56987, 0.10850], -[9349, 1.00000, 0.17524, 0.13750], -[9350, 0.80264, 0.58027, 0.07434], -[9351, 0.87554, 0.61393, 0.36285], -[9352, 0.89498, 0.59357, 0.40497], -[9353, 0.59796, 0.89676, 0.47376], -[9354, 0.51934, 0.90556, 0.23032], -[9355, 0.89609, 0.55497, 0.27297], -[9356, 0.83138, 0.67673, 0.38442], -[9357, 0.62225, 0.88024, 0.47662], -[9358, 0.77136, 0.69862, 0.21799], -[9359, 0.67416, 0.79502, 0.22396], -[9360, 0.90091, 0.51462, 0.20621], -[9361, 0.83887, 0.67593, 0.45225], -[9362, 0.75025, 0.66398, 0.10109], -[9363, 0.75045, 0.67431, 0.11907], -[9364, 0.81227, 0.64063, 0.19527], -[9365, 0.73345, 0.79056, 0.48646], -[9366, 0.82143, 0.68585, 0.36584], -[9367, 0.91136, 0.50000, 0.21250], -[9368, 0.82776, 0.62087, 0.19564], -[9369, 0.24019, 0.92500, 0.00000], -[9370, 1.00000, 0.24019, 0.17500], -[9371, 0.80871, 0.65823, 0.22420], -[9372, 0.67964, 0.76309, 0.15478], -[9373, 0.73458, 0.71595, 0.16637], -[9374, 0.58252, 0.83964, 0.15467], -[9375, 0.92046, 0.54011, 0.34293], -[9376, 0.74472, 0.62104, 0.02735], -[9377, 0.63472, 0.79119, 0.13275], -[9378, 0.57591, 0.89073, 0.30307], -[9379, 0.63682, 0.85779, 0.34993], -[9380, 0.60825, 0.73750, 0.00000], -[9381, 0.71865, 0.79933, 0.40769], -[9382, 0.51943, 0.84722, 0.08007], -[9383, 0.63497, 0.73389, 0.02863], -[9384, 0.75083, 0.64385, 0.06910], -[9385, 0.64661, 0.75557, 0.08165], -[9386, 0.88971, 0.50000, 0.15000], -[9387, 0.79329, 0.71261, 0.33541], -[9388, 1.00000, 0.15359, 0.12500], -[9389, 0.84162, 0.54760, 0.10497], -[9390, 0.76915, 0.61244, 0.05553], -[9391, 0.81563, 0.54767, 0.05384], -[9392, 0.66697, 0.72541, 0.06036], -[9393, 0.88572, 0.55274, 0.22717], -[9394, 1.00000, 0.06699, 0.10000], -[9395, 0.90644, 0.51748, 0.22566], -[9396, 0.55072, 0.84831, 0.12345], -[9397, 0.57436, 0.82968, 0.11713], -[9398, 0.57979, 0.80571, 0.07624], -[9399, 0.57500, 0.91340, 0.50000], -[9400, 0.59327, 0.88463, 0.32566], -[9401, 0.52040, 0.87154, 0.13317], -[9402, 0.66950, 0.84629, 0.47486], -[9403, 0.88523, 0.61425, 0.43564], -[9404, 0.95466, 0.50000, 0.43750], -[9405, 0.95466, 0.06250, 0.00000], -[9406, 0.70200, 0.80880, 0.36461], -[9407, 0.76282, 0.60012, 0.02748], -[9408, 0.69124, 0.79761, 0.27327], -[9409, 0.57004, 0.89908, 0.32078], -[9410, 0.82143, 0.59775, 0.13482], -[9411, 0.66864, 0.69956, 0.02141], -[9412, 0.58085, 0.90786, 0.43695], -[9413, 0.67590, 0.83492, 0.39197], -[9414, 0.75343, 0.62722, 0.04768], -[9415, 0.85844, 0.59484, 0.22594], -[9416, 0.50000, 0.95670, 0.47500], -[9417, 0.75735, 0.75194, 0.33596], -[9418, 0.92796, 0.54544, 0.41442], -[9419, 0.67032, 0.75787, 0.12283], -[9420, 0.87045, 0.54095, 0.15993], -[9421, 0.66326, 0.82304, 0.27920], -[9422, 0.39175, 1.00000, 0.38750], -[9423, 1.00000, 0.39175, 0.38750], -[9424, 0.76029, 0.64912, 0.09163], -[9425, 1.00000, 0.26184, 0.18750], -[9426, 0.90767, 0.55314, 0.30919], -[9427, 0.82500, 0.69689, 0.50000], -[9428, 0.53686, 0.85713, 0.12116], -[9429, 0.80381, 0.72009, 0.45754], -[9430, 0.72218, 0.72816, 0.16121], -[9431, 0.51381, 0.94805, 0.43874], -[9432, 1.00000, 0.34845, 0.28750], -[9433, 0.67436, 0.81002, 0.26388], -[9434, 0.89725, 0.59911, 0.44793], -[9435, 0.32679, 0.90000, 0.00000], -[9436, 0.90000, 0.32679, 0.00000], -[9437, 0.77603, 0.75036, 0.46023], -[9438, 0.82269, 0.52452, 0.03641], -[9439, 0.64347, 0.74113, 0.04870], -[9440, 0.80188, 0.64546, 0.17228], -[9441, 0.50000, 0.87010, 0.10000], -[9442, 0.83015, 0.55320, 0.08539], -[9443, 0.84907, 0.55846, 0.13345], -[9444, 0.88185, 0.59092, 0.29921], -[9445, 0.91896, 0.55297, 0.36921], -[9446, 0.56263, 0.92169, 0.46285], -[9447, 0.92175, 0.52835, 0.30334], -[9448, 0.78923, 0.56993, 0.03118], -[9449, 0.30311, 1.00000, 0.22500], -[9450, 0.08660, 1.00000, 0.10000], -[9451, 0.80271, 0.56952, 0.05407], -[9452, 0.86322, 0.63520, 0.36237], -[9453, 1.00000, 0.13194, 0.11250], -[9454, 1.00000, 0.37010, 0.32500], -[9455, 0.53369, 0.82622, 0.05249], -[9456, 0.76361, 0.76302, 0.45069], -[9457, 0.58086, 0.77598, 0.02229], -[9458, 0.50000, 0.95670, 0.45000], -[9459, 0.65070, 0.85371, 0.37492], -[9460, 0.85363, 0.51875, 0.08750], -[9461, 0.67351, 0.82727, 0.32692], -[9462, 0.54704, 0.90568, 0.27966], -[9463, 0.55133, 0.89094, 0.23478], -[9464, 0.75449, 0.72246, 0.22269], -[9465, 0.82090, 0.67550, 0.30502], -[9466, 0.65829, 0.84101, 0.33376], -[9467, 0.61532, 0.84791, 0.23411], -[9468, 0.72126, 0.70252, 0.10689], -[9469, 0.84490, 0.65086, 0.32449], -[9470, 0.52444, 0.93953, 0.39692], -[9471, 0.74379, 0.78158, 0.43436], -[9472, 0.92177, 0.56221, 0.44816], -[9473, 0.61613, 0.88317, 0.40600], -[9474, 0.83280, 0.59519, 0.15265], -[9475, 0.82845, 0.69107, 0.43192], -[9476, 0.71789, 0.75483, 0.21116], -[9477, 0.57830, 0.83856, 0.13811], -[9478, 0.59531, 0.81875, 0.12070], -[9479, 0.68782, 0.83379, 0.48125], -[9480, 0.74105, 0.78571, 0.45362], -[9481, 0.78234, 0.69807, 0.23678], -[9482, 0.59582, 0.90077, 0.45125], -[9483, 0.80668, 0.68415, 0.27642], -[9484, 0.77756, 0.74788, 0.42999], -[9485, 0.91863, 0.56982, 0.48289], -[9486, 0.84641, 0.50000, 0.05000], -[9487, 0.70359, 0.75519, 0.17811], -[9488, 0.73426, 0.75779, 0.26411], -[9489, 0.95466, 0.50000, 0.41250], -[9490, 0.95466, 0.08750, 0.00000], -[9491, 0.79889, 0.71526, 0.36115], -[9492, 0.82252, 0.55186, 0.06635], -[9493, 0.64185, 0.87004, 0.48408], -[9494, 1.00000, 0.32679, 0.25000], -[9495, 0.71560, 0.80786, 0.43198], -[9496, 0.21651, 1.00000, 0.15000], -[9497, 0.19486, 1.00000, 0.13750], -[9498, 0.80440, 0.71734, 0.41189], -[9499, 0.68763, 0.74430, 0.12236], -[9500, 0.50000, 0.93505, 0.28750], -[9501, 0.58237, 0.90718, 0.41405], -[9502, 0.81814, 0.66639, 0.26308], -[9503, 0.92617, 0.55742, 0.46698], -[9504, 0.71966, 0.74455, 0.18791], -[9505, 0.79184, 0.63514, 0.12650], -[9506, 0.63516, 0.80699, 0.16039], -[9507, 0.73816, 0.61250, 0.00000], -[9508, 0.80972, 0.68859, 0.29925], -[9509, 0.87025, 0.57975, 0.22311], -[9510, 0.69790, 0.80025, 0.29349], -[9511, 0.76321, 0.76338, 0.43002], -[9512, 0.74230, 0.70543, 0.15127], -[9513, 0.79935, 0.67779, 0.23175], -[9514, 0.60148, 0.87003, 0.27280], -[9515, 1.00000, 0.28349, 0.20000], -[9516, 0.61250, 0.89175, 0.50000], -[9517, 0.57565, 0.85784, 0.17881], -[9518, 0.87051, 0.58917, 0.24401], -[9519, 0.66138, 0.75795, 0.10168], -[9520, 0.56826, 0.90966, 0.35790], -[9521, 0.80311, 0.52500, 0.00000], -[9522, 0.36806, 1.00000, 0.31250], -[9523, 0.23816, 1.00000, 0.16250], -[9524, 0.34641, 1.00000, 0.27500], -[9525, 0.17321, 1.00000, 0.12500], -[9526, 0.02165, 1.00000, 0.08750], -[9527, 0.53717, 0.92731, 0.35079], -[9528, 0.61268, 0.88026, 0.35688], -[9529, 0.76573, 0.71869, 0.23949], -[9530, 0.50000, 0.95670, 0.42500], -[9531, 0.67505, 0.84064, 0.40763], -[9532, 0.73336, 0.74030, 0.20833], -[9533, 0.69466, 0.82133, 0.38240], -[9534, 0.61272, 0.75568, 0.02613], -[9535, 0.77409, 0.73088, 0.30598], -[9536, 0.60930, 0.85952, 0.25299], -[9537, 0.41220, 1.00000, 0.46623], -[9538, 0.93825, 0.53849, 0.47184], -[9539, 1.00000, 0.41296, 0.47586], -[9540, 0.93301, 0.50000, 0.27500], -[9541, 0.93301, 0.22500, 0.00000], -[9542, 0.61272, 0.89011, 0.43994], -[9543, 0.73830, 0.79072, 0.46731], -[9544, 0.66111, 0.84528, 0.35864], -[9545, 0.86469, 0.57017, 0.18563], -[9546, 0.84652, 0.66694, 0.39865], -[9547, 0.69486, 0.66250, 0.00000], -[9548, 0.77766, 0.69253, 0.20440], -[9549, 0.57097, 0.91098, 0.37415], -[9550, 0.87343, 0.59511, 0.26598], -[9551, 0.82915, 0.65371, 0.26122], -[9552, 0.71688, 0.76558, 0.23181], -[9553, 0.70123, 0.82044, 0.41520], -[9554, 0.94023, 0.51875, 0.36250], -[9555, 0.73125, 0.67540, 0.07434], -[9556, 0.83607, 0.68715, 0.47006], -[9557, 1.00000, 0.11029, 0.10000], -[9558, 1.00000, 0.04534, 0.08750], -[9559, 0.63424, 0.86797, 0.37104], -[9560, 0.70727, 0.80154, 0.32803], -[9561, 0.39175, 1.00000, 0.36250], -[9562, 1.00000, 0.39175, 0.36250], -[9563, 0.62990, 0.72500, 0.00000], -[9564, 0.56632, 0.87120, 0.19498], -[9565, 0.63596, 0.84395, 0.26325], -[9566, 0.90865, 0.58531, 0.43255], -[9567, 0.83041, 0.58588, 0.12590], -[9568, 0.74806, 0.76718, 0.34299], -[9569, 0.78901, 0.62607, 0.10207], -[9570, 0.53775, 0.89721, 0.21941], -[9571, 0.59635, 0.81040, 0.09933], -[9572, 0.76580, 0.72701, 0.25929], -[9573, 0.89382, 0.59704, 0.36746], -[9574, 0.80342, 0.55583, 0.03254], -[9575, 0.58561, 0.91091, 0.48327], -[9576, 0.57695, 0.88227, 0.25136], -[9577, 0.88816, 0.61379, 0.41312], -[9578, 0.41136, 1.00000, 0.43750], -[9579, 0.25981, 1.00000, 0.17500], -[9580, 0.15155, 1.00000, 0.11250], -[9581, 0.59641, 0.90133, 0.42830], -[9582, 0.62101, 0.87924, 0.37938], -[9583, 0.63950, 0.81429, 0.18173], -[9584, 0.76732, 0.73275, 0.28176], -[9585, 0.74801, 0.69128, 0.13128], -[9586, 1.00000, 0.41340, 0.45000], -[9587, 0.55262, 0.91348, 0.31671], -[9588, 0.89101, 0.59620, 0.34477], -[9589, 0.57513, 0.82041, 0.08811], -[9590, 0.66613, 0.77493, 0.14048], -[9591, 0.85592, 0.64936, 0.36129], -[9592, 0.70000, 0.82679, 0.50000], -[9593, 0.51638, 0.92276, 0.26438], -[9594, 0.86806, 0.50000, 0.08750], -[9595, 0.80465, 0.68238, 0.25361], -[9596, 0.77721, 0.58451, 0.02234], -[9597, 0.84407, 0.59516, 0.17246], -[9598, 0.83011, 0.50905, 0.02487], -[9599, 0.95466, 0.50000, 0.38750], -[9600, 0.95466, 0.11250, 0.00000], -[9601, 0.69689, 0.69413, 0.04547], -[9602, 0.63770, 0.82441, 0.20347], -[9603, 0.88905, 0.61812, 0.45781], -[9604, 0.50000, 0.91340, 0.20000], -[9605, 0.32476, 1.00000, 0.23750], -[9606, 0.06495, 1.00000, 0.08750], -[9607, 0.71483, 0.80587, 0.38176], -[9608, 0.76917, 0.67118, 0.13621], -[9609, 0.68917, 0.83067, 0.40265], -[9610, 0.51396, 0.93701, 0.31982], -[9611, 0.53845, 0.81445, 0.02948], -[9612, 0.94301, 0.52534, 0.40286], -[9613, 0.60307, 0.89321, 0.38504], -[9614, 0.91560, 0.56632, 0.37420], -[9615, 0.83955, 0.67192, 0.36351], -[9616, 0.85750, 0.65731, 0.41182], -[9617, 0.50000, 0.95670, 0.40000], -[9618, 0.55376, 0.88516, 0.20820], -[9619, 0.56903, 0.92013, 0.42997], -[9620, 0.63667, 0.76787, 0.07521], -[9621, 0.72891, 0.79585, 0.39611], -[9622, 0.88614, 0.52418, 0.16008], -[9623, 0.59646, 0.85913, 0.21404], -[9624, 0.30514, 0.91250, 0.00000], -[9625, 0.91250, 0.30514, 0.00000], -[9626, 1.00000, 0.30514, 0.21250], -[9627, 0.81671, 0.68842, 0.31326], -[9628, 0.53280, 0.94219, 0.43509], -[9629, 0.69593, 0.71765, 0.07985], -[9630, 0.74917, 0.66303, 0.08162], -[9631, 0.76639, 0.76202, 0.41085], -[9632, 0.15359, 0.95000, 0.00000], -[9633, 0.86131, 0.65738, 0.45400], -[9634, 0.93750, 0.54534, 0.50000], -[9635, 0.75000, 0.78349, 0.50000], -[9636, 0.60054, 0.79942, 0.07960], -[9637, 0.81250, 0.71854, 0.50000], -[9638, 0.64846, 0.86947, 0.50000], -[9639, 1.00000, 0.41340, 0.42500], -[9640, 0.89746, 0.52712, 0.19464], -[9641, 0.50000, 0.89175, 0.13750], -[9642, 0.58182, 0.91474, 0.46292], -[9643, 0.21854, 0.93750, 0.00000], -[9644, 0.76063, 0.68989, 0.15042], -[9645, 0.95000, 0.52369, 0.50000], -[9646, 0.62779, 0.87766, 0.38859], -[9647, 0.88199, 0.62405, 0.40258], -[9648, 0.91263, 0.58493, 0.45741], -[9649, 0.83223, 0.61477, 0.17395], -[9650, 0.28146, 1.00000, 0.18750], -[9651, 0.12990, 1.00000, 0.10000], -[9652, 0.61376, 0.80690, 0.11389], -[9653, 0.88505, 0.54973, 0.19764], -[9654, 1.00000, 0.37010, 0.30000], -[9655, 0.78263, 0.73126, 0.32729], -[9656, 0.78146, 0.56250, 0.00000], -[9657, 0.92500, 0.56699, 0.50000], -[9658, 0.91056, 0.56318, 0.32445], -[9659, 0.88906, 0.61212, 0.39048], -[9660, 0.80291, 0.60931, 0.09847], -[9661, 0.81532, 0.69867, 0.34407], -[9662, 0.93425, 0.51952, 0.31404], -[9663, 0.52278, 0.94084, 0.36276], -[9664, 0.67797, 0.80726, 0.24302], -[9665, 0.59962, 0.83065, 0.14226], -[9666, 0.56973, 0.92336, 0.48038], -[9667, 0.91150, 0.58280, 0.41518], -[9668, 0.51823, 0.87093, 0.11179], -[9669, 0.66303, 0.85582, 0.42394], -[9670, 1.00000, 0.34845, 0.26250], -[9671, 1.00000, 0.08864, 0.08750], -[9672, 0.88515, 0.53913, 0.17748], -[9673, 0.91136, 0.50000, 0.18750], -[9674, 0.88029, 0.63439, 0.46958], -[9675, 0.90129, 0.57784, 0.32078], -[9676, 0.81985, 0.56612, 0.06896], -[9677, 0.55119, 0.86252, 0.13827], -[9678, 0.73975, 0.78956, 0.41045], -[9679, 0.73345, 0.63662, 0.01480], -[9680, 0.53982, 0.90555, 0.24071], -[9681, 0.65485, 0.86531, 0.46626], -[9682, 0.78766, 0.73563, 0.36863], -[9683, 0.94587, 0.53091, 0.45180], -[9684, 0.88325, 0.57381, 0.23639], -[9685, 0.68129, 0.74664, 0.10337], -[9686, 0.71392, 0.68337, 0.05027], -[9687, 0.51786, 0.84067, 0.04827], -[9688, 0.59588, 0.84890, 0.17858], -[9689, 0.78508, 0.71519, 0.27374], -[9690, 0.60772, 0.78620, 0.06225], -[9691, 0.62585, 0.87572, 0.35681], -[9692, 0.95318, 0.51927, 0.47006], -[9693, 0.91250, 0.58864, 0.50000], -[9694, 1.00000, 0.21854, 0.13750], -[9695, 0.67051, 0.79996, 0.20056], -[9696, 0.79326, 0.65500, 0.15224], -[9697, 0.87112, 0.62320, 0.32109], -[9698, 0.66186, 0.86088, 0.49049], -[9699, 0.76972, 0.70339, 0.19652], -[9700, 1.00000, 0.19689, 0.12500], -[9701, 0.86427, 0.60622, 0.24502], -[9702, 0.80855, 0.65907, 0.19774], -[9703, 0.94023, 0.51875, 0.33750], -[9704, 0.70858, 0.78786, 0.26180], -[9705, 0.70119, 0.78165, 0.22264], -[9706, 0.68319, 0.78584, 0.19123], -[9707, 0.88077, 0.63052, 0.42018], -[9708, 0.85272, 0.63903, 0.28978], -[9709, 0.82385, 0.69842, 0.38490], -[9710, 0.65512, 0.77591, 0.11455], -[9711, 1.00000, 0.39175, 0.33750], -[9712, 0.68761, 0.71555, 0.05830], -[9713, 0.68106, 0.70910, 0.03820], -[9714, 0.56741, 0.86259, 0.16227], -[9715, 0.79557, 0.59130, 0.05549], -[9716, 1.00000, 0.24019, 0.15000], -[9717, 0.79269, 0.71844, 0.31111], -[9718, 0.47835, 0.83750, 0.00000], -[9719, 0.83750, 0.47835, 0.00000], -[9720, 0.95466, 0.50000, 0.36250], -[9721, 0.95466, 0.13750, 0.00000], -[9722, 0.83503, 0.66432, 0.29574], -[9723, 0.65359, 0.75174, 0.06636], -[9724, 0.93436, 0.54351, 0.39034], -[9725, 0.86179, 0.53087, 0.10494], -[9726, 0.36806, 1.00000, 0.28750], -[9727, 0.50000, 0.82500, 0.00000], -[9728, 0.82500, 0.50000, 0.00000], -[9729, 1.00000, 0.42500, 0.50000], -[9730, 0.42500, 1.00000, 0.50000], -[9731, 1.00000, 0.00000, 0.07500], -[9732, 0.00000, 1.00000, 0.07500], -[9733, 0.50000, 0.93505, 0.26250], -[9734, 0.54150, 0.94187, 0.47957], -[9735, 0.90741, 0.58088, 0.35846], -[9736, 1.00000, 0.17524, 0.11250], -[9737, 0.41340, 1.00000, 0.40000], -[9738, 0.50000, 0.95670, 0.37500], -[9739, 1.00000, 0.41340, 0.40000], -[9740, 0.02221, 0.96458, 0.00000], -[9741, 0.77046, 0.69363, 0.17413], -[9742, 0.45670, 0.85000, 0.00000], -[9743, 0.85000, 0.45670, 0.00000], -[9744, 0.54895, 0.84983, 0.10305], -[9745, 0.62996, 0.86059, 0.29097], -[9746, 1.00000, 0.02369, 0.07500], -[9747, 0.65178, 0.81825, 0.20485], -[9748, 0.78632, 0.62176, 0.07967], -[9749, 0.30311, 1.00000, 0.20000], -[9750, 0.10825, 1.00000, 0.08750], -[9751, 0.77683, 0.65863, 0.11966], -[9752, 0.63192, 0.86761, 0.32720], -[9753, 0.70063, 0.74984, 0.14114], -[9754, 0.53502, 0.84271, 0.06923], -[9755, 0.81677, 0.60795, 0.11888], -[9756, 0.58179, 0.90443, 0.33977], -[9757, 0.65155, 0.71250, 0.00000], -[9758, 0.88971, 0.50000, 0.12500], -[9759, 0.52165, 0.81250, 0.00000], -[9760, 0.88744, 0.58712, 0.27629], -[9761, 0.75564, 0.76987, 0.36328], -[9762, 0.71370, 0.74645, 0.15964], -[9763, 1.00000, 0.32679, 0.22500], -[9764, 0.90000, 0.61029, 0.50000], -[9765, 1.00000, 0.26184, 0.16250], -[9766, 0.72068, 0.69596, 0.07722], -[9767, 0.38971, 1.00000, 0.32500], -[9768, 0.34641, 1.00000, 0.25000], -[9769, 0.04330, 1.00000, 0.07500], -[9770, 0.85005, 0.62792, 0.24376], -[9771, 0.65549, 0.80260, 0.17012], -[9772, 0.55774, 0.80000, 0.01875], -[9773, 0.62074, 0.78859, 0.08101], -[9774, 0.75436, 0.77683, 0.39814], -[9775, 0.85145, 0.50885, 0.05381], -[9776, 0.84665, 0.60875, 0.19078], -[9777, 0.93301, 0.50000, 0.25000], -[9778, 0.93301, 0.25000, 0.00000], -[9779, 0.67795, 0.82689, 0.30088], -[9780, 0.62956, 0.79358, 0.10386], -[9781, 0.74626, 0.74276, 0.22715], -[9782, 0.83892, 0.54099, 0.06803], -[9783, 0.43505, 0.86250, 0.00000], -[9784, 0.86250, 0.43505, 0.00000], -[9785, 0.66258, 0.85527, 0.38737], -[9786, 0.65111, 0.72390, 0.01495], -[9787, 0.80811, 0.70265, 0.30880], -[9788, 0.80367, 0.72368, 0.38197], -[9789, 1.00000, 0.15359, 0.10000], -[9790, 0.73637, 0.75795, 0.24125], -[9791, 0.50000, 0.84845, 0.03750], -[9792, 0.84168, 0.68502, 0.42154], -[9793, 0.65184, 0.85141, 0.31538], -[9794, 0.73603, 0.71082, 0.12988], -[9795, 0.84377, 0.52035, 0.05135], -[9796, 0.66473, 0.81595, 0.22367], -[9797, 0.84911, 0.66234, 0.34393], -[9798, 0.55025, 0.88459, 0.18551], -[9799, 0.65180, 0.84043, 0.26951], -[9800, 0.73478, 0.80131, 0.45178], -[9801, 0.74341, 0.68241, 0.09251], -[9802, 0.91871, 0.56330, 0.34741], -[9803, 0.95614, 0.51371, 0.41891], -[9804, 0.67402, 0.78345, 0.15851], -[9805, 0.06663, 0.96458, 0.00000], -[9806, 0.87708, 0.53415, 0.13902], -[9807, 0.85340, 0.51531, 0.06290], -[9808, 0.59633, 0.88984, 0.30633], -[9809, 0.58731, 0.86325, 0.19190], -[9810, 1.00000, 0.06699, 0.07500], -[9811, 0.68632, 0.84208, 0.42931], -[9812, 0.53383, 0.94063, 0.37599], -[9813, 0.91725, 0.54771, 0.29066], -[9814, 0.54330, 0.80000, 0.00000], -[9815, 0.68395, 0.76301, 0.13223], -[9816, 0.83822, 0.67272, 0.32658], -[9817, 0.53805, 0.91587, 0.26114], -[9818, 0.88086, 0.61997, 0.34145], -[9819, 0.90893, 0.53846, 0.23658], -[9820, 0.70900, 0.82613, 0.48072], -[9821, 0.72416, 0.77431, 0.25176], -[9822, 0.80053, 0.70820, 0.29211], -[9823, 0.86425, 0.54466, 0.12313], -[9824, 0.55511, 0.93558, 0.45248], -[9825, 0.82143, 0.59550, 0.10458], -[9826, 0.65610, 0.85585, 0.34902], -[9827, 0.61858, 0.87589, 0.31045], -[9828, 0.66360, 0.84084, 0.30390], -[9829, 0.71651, 0.65000, 0.00000], -[9830, 0.28349, 0.92500, 0.00000], -[9831, 1.00000, 0.28349, 0.17500], -[9832, 0.63068, 0.81029, 0.13709], -[9833, 0.92283, 0.51672, 0.24033], -[9834, 0.87197, 0.64901, 0.43242], -[9835, 0.70589, 0.82724, 0.44037], -[9836, 0.95100, 0.51754, 0.38180], -[9837, 0.68435, 0.73224, 0.07373], -[9838, 0.73449, 0.73347, 0.17016], -[9839, 0.59109, 0.87369, 0.22870], -[9840, 0.87873, 0.50990, 0.10721], -[9841, 0.41340, 0.87500, 0.00000], -[9842, 0.87500, 0.41340, 0.00000], -[9843, 0.41340, 1.00000, 0.37500], -[9844, 1.00000, 0.41340, 0.37500], -[9845, 0.81000, 0.63030, 0.13495], -[9846, 0.84786, 0.56733, 0.11787], -[9847, 0.59782, 0.88675, 0.29252], -[9848, 0.72274, 0.78928, 0.29620], -[9849, 0.87930, 0.60601, 0.28447], -[9850, 0.61230, 0.85186, 0.20620], -[9851, 0.88750, 0.63194, 0.50000], -[9852, 0.75249, 0.72668, 0.19542], -[9853, 0.55546, 0.87424, 0.16196], -[9854, 0.53398, 0.92441, 0.28207], -[9855, 0.72699, 0.79534, 0.33838], -[9856, 0.83541, 0.63633, 0.20952], -[9857, 0.77757, 0.74751, 0.34560], -[9858, 0.65493, 0.86881, 0.44105], -[9859, 0.78122, 0.75932, 0.48072], -[9860, 0.87595, 0.63747, 0.38338], -[9861, 0.75981, 0.60000, 0.00000], -[9862, 0.73474, 0.72519, 0.15130], -[9863, 0.74378, 0.66339, 0.05930], -[9864, 0.21651, 1.00000, 0.12500], -[9865, 0.89677, 0.56901, 0.25599], -[9866, 0.64824, 0.87204, 0.41718], -[9867, 1.00000, 0.13194, 0.08750], -[9868, 1.00000, 0.37010, 0.27500], -[9869, 0.90871, 0.56963, 0.30655], -[9870, 0.50000, 0.87010, 0.07500], -[9871, 0.50000, 0.95670, 0.35000], -[9872, 0.95466, 0.50000, 0.33750], -[9873, 0.95466, 0.16250, 0.00000], -[9874, 0.12946, 0.95972, 0.00000], -[9875, 0.80000, 0.74019, 0.50000], -[9876, 0.86088, 0.64118, 0.31114], -[9877, 0.74029, 0.78636, 0.35293], -[9878, 0.32476, 1.00000, 0.21250], -[9879, 0.23816, 1.00000, 0.13750], -[9880, 0.19486, 1.00000, 0.11250], -[9881, 0.08660, 1.00000, 0.07500], -[9882, 0.84689, 0.65723, 0.30252], -[9883, 0.62474, 0.75094, 0.01629], -[9884, 0.72211, 0.66401, 0.02471], -[9885, 0.65797, 0.82958, 0.24088], -[9886, 0.68825, 0.79146, 0.20304], -[9887, 0.81800, 0.63326, 0.15627], -[9888, 0.82768, 0.65315, 0.22297], -[9889, 0.80066, 0.60442, 0.07337], -[9890, 0.85507, 0.52629, 0.07539], -[9891, 1.00000, 0.39175, 0.31250], -[9892, 0.89632, 0.62033, 0.47849], -[9893, 0.73265, 0.69738, 0.09310], -[9894, 0.68660, 0.84565, 0.45232], -[9895, 0.77941, 0.69589, 0.18828], -[9896, 0.82150, 0.71075, 0.40559], -[9897, 1.00000, 0.43330, 0.46473], -[9898, 0.86034, 0.58485, 0.17290], -[9899, 0.80556, 0.72871, 0.40349], -[9900, 0.56495, 0.78750, 0.00000], -[9901, 0.84887, 0.64195, 0.26190], -[9902, 0.73973, 0.79191, 0.37730], -[9903, 0.75903, 0.78241, 0.46621], -[9904, 0.85551, 0.67632, 0.48584], -[9905, 0.72206, 0.73375, 0.13980], -[9906, 0.90494, 0.57058, 0.28742], -[9907, 0.61648, 0.88396, 0.33185], -[9908, 0.82789, 0.68742, 0.32154], -[9909, 0.82095, 0.71459, 0.42756], -[9910, 0.75946, 0.77934, 0.42433], -[9911, 0.76057, 0.75947, 0.31390], -[9912, 0.50000, 0.91340, 0.17500], -[9913, 0.56820, 0.84180, 0.10193], -[9914, 0.75846, 0.70835, 0.16390], -[9915, 0.25981, 1.00000, 0.15000], -[9916, 0.17321, 1.00000, 0.10000], -[9917, 0.87314, 0.58635, 0.21047], -[9918, 0.92782, 0.56559, 0.40341], -[9919, 0.86456, 0.64586, 0.34033], -[9920, 0.60292, 0.77587, 0.02595], -[9921, 1.00000, 0.34845, 0.23750], -[9922, 0.57471, 0.92735, 0.49015], -[9923, 0.68029, 0.83900, 0.34546], -[9924, 0.69642, 0.79533, 0.22962], -[9925, 0.51846, 0.89775, 0.15953], -[9926, 0.43505, 1.00000, 0.46250], -[9927, 0.56250, 0.93505, 0.50000], -[9928, 0.70060, 0.78129, 0.20087], -[9929, 0.59679, 0.87784, 0.24705], -[9930, 1.00000, 0.30514, 0.18750], -[9931, 0.53761, 0.94842, 0.45252], -[9932, 0.52500, 0.95670, 0.50000], -[9933, 0.63906, 0.76328, 0.05284], -[9934, 0.67663, 0.79550, 0.18323], -[9935, 0.75486, 0.75435, 0.27154], -[9936, 0.90008, 0.59328, 0.32978], -[9937, 0.39175, 0.88750, 0.00000], -[9938, 0.88750, 0.39175, 0.00000], -[9939, 0.19689, 0.95000, 0.00000], -[9940, 0.93095, 0.56496, 0.42615], -[9941, 0.93102, 0.55031, 0.35173], -[9942, 0.79560, 0.74101, 0.40213], -[9943, 0.88807, 0.51447, 0.12809], -[9944, 0.62095, 0.82673, 0.14982], -[9945, 0.72752, 0.78171, 0.27324], -[9946, 0.38971, 1.00000, 0.30000], -[9947, 0.36806, 1.00000, 0.26250], -[9948, 0.02165, 1.00000, 0.06250], -[9949, 0.84641, 0.50000, 0.02500], -[9950, 0.52117, 0.91346, 0.20667], -[9951, 0.61816, 0.87511, 0.28974], -[9952, 0.73750, 0.80514, 0.50000], -[9953, 0.79500, 0.73259, 0.34660], -[9954, 0.94307, 0.54626, 0.43169], -[9955, 0.68750, 0.84845, 0.50000], -[9956, 0.75553, 0.74705, 0.24772], -[9957, 0.64747, 0.86933, 0.36713], -[9958, 0.69666, 0.82813, 0.35343], -[9959, 0.71215, 0.72406, 0.09849], -[9960, 0.90437, 0.60734, 0.42338], -[9961, 0.61757, 0.84137, 0.17839], -[9962, 0.72197, 0.79789, 0.31328], -[9963, 0.86489, 0.65724, 0.38708], -[9964, 1.00000, 0.11029, 0.07500], -[9965, 0.64543, 0.78182, 0.09384], -[9966, 0.93046, 0.53226, 0.29085], -[9967, 0.87500, 0.65359, 0.50000], -[9968, 0.85801, 0.61780, 0.22620], -[9969, 0.53259, 0.89826, 0.18015], -[9970, 0.51674, 0.95488, 0.38168], -[9971, 0.58384, 0.89475, 0.27335], -[9972, 0.85565, 0.67776, 0.46292], -[9973, 0.64701, 0.87320, 0.39116], -[9974, 0.84012, 0.64853, 0.24171], -[9975, 0.28146, 1.00000, 0.16250], -[9976, 0.15155, 1.00000, 0.08750], -[9977, 0.69627, 0.69312, 0.02259], -[9978, 0.43505, 1.00000, 0.43750], -[9979, 1.00000, 0.43505, 0.43750], -[9980, 0.62176, 0.77146, 0.04015], -[9981, 0.67321, 0.70000, 0.00000], -[9982, 0.68611, 0.82107, 0.28022], -[9983, 0.50000, 0.93505, 0.23750], -[9984, 0.63220, 0.84384, 0.21440], -[9985, 0.70296, 0.81328, 0.30571], -[9986, 0.56047, 0.93015, 0.38160], -[9987, 0.41340, 1.00000, 0.35000], -[9988, 1.00000, 0.41340, 0.35000], -[9989, 1.00000, 0.04534, 0.06250], -[9990, 0.82514, 0.63864, 0.17618], -[9991, 0.64154, 0.79525, 0.11321], -[9992, 0.71120, 0.82284, 0.39628], -[9993, 0.74189, 0.70189, 0.11193], -[9994, 0.65047, 0.86078, 0.32777], -[9995, 0.87005, 0.55576, 0.14238], -[9996, 0.57650, 0.79471, 0.02055], -[9997, 0.66564, 0.79357, 0.15204], -[9998, 0.88115, 0.55877, 0.17555], -[9999, 0.79988, 0.66834, 0.17196], -[10000, 0.60000, 0.91340, 0.50000], -[10001, 0.80282, 0.70291, 0.26374], -[10002, 0.72407, 0.72466, 0.11918], -[10003, 0.91136, 0.50000, 0.16250], -[10004, 0.77212, 0.76552, 0.38899], -[10005, 0.78205, 0.64276, 0.08792], -[10006, 0.95637, 0.52474, 0.43246], -[10007, 0.82955, 0.71076, 0.46439], -[10008, 0.50641, 0.96849, 0.48558], -[10009, 0.52757, 0.89033, 0.14838], -[10010, 0.77301, 0.76186, 0.37055], -[10011, 0.58660, 0.77500, 0.00000], -[10012, 0.52561, 0.92339, 0.24337], -[10013, 0.86806, 0.50000, 0.06250], -[10014, 0.79676, 0.67972, 0.18677], -[10015, 0.77035, 0.62008, 0.03391], -[10016, 0.70137, 0.76564, 0.15779], -[10017, 0.80600, 0.62877, 0.11239], -[10018, 0.93306, 0.51725, 0.26088], -[10019, 0.92048, 0.58935, 0.47316], -[10020, 0.66829, 0.72521, 0.02796], -[10021, 0.50000, 0.89175, 0.11250], -[10022, 0.85901, 0.57574, 0.14484], -[10023, 0.53798, 0.93354, 0.31382], -[10024, 0.34641, 1.00000, 0.22500], -[10025, 0.06495, 1.00000, 0.06250], -[10026, 0.76713, 0.74421, 0.26909], -[10027, 0.82067, 0.67406, 0.23942], -[10028, 0.69215, 0.77793, 0.16600], -[10029, 0.62711, 0.84134, 0.19214], -[10030, 0.50000, 0.95670, 0.32500], -[10031, 0.93301, 0.50000, 0.22500], -[10032, 0.93301, 0.27500, 0.00000], -[10033, 0.67640, 0.85842, 0.45666], -[10034, 0.84206, 0.52298, 0.03765], -[10035, 0.55082, 0.93003, 0.33253], -[10036, 0.95438, 0.53416, 0.48315], -[10037, 0.58412, 0.87813, 0.20986], -[10038, 0.95466, 0.50000, 0.31250], -[10039, 0.95466, 0.18750, 0.00000], -[10040, 0.52760, 0.82466, 0.01200], -[10041, 0.75103, 0.79517, 0.48445], -[10042, 0.55259, 0.92161, 0.29523], -[10043, 0.71237, 0.78747, 0.23710], -[10044, 0.70407, 0.68001, 0.01148], -[10045, 1.00000, 0.32679, 0.20000], -[10046, 0.43505, 1.00000, 0.41250], -[10047, 1.00000, 0.43505, 0.41250], -[10048, 0.78195, 0.68156, 0.15222], -[10049, 0.91165, 0.55314, 0.25531], -[10050, 0.71368, 0.81475, 0.34581], -[10051, 0.55670, 0.84313, 0.08025], -[10052, 0.37010, 0.90000, 0.00000], -[10053, 0.90000, 0.37010, 0.00000], -[10054, 0.53126, 0.94194, 0.33410], -[10055, 0.88111, 0.64150, 0.40326], -[10056, 0.91318, 0.57936, 0.33359], -[10057, 0.87415, 0.62554, 0.29536], -[10058, 0.73650, 0.80903, 0.47953], -[10059, 0.76893, 0.77843, 0.48405], -[10060, 0.26184, 0.93750, 0.00000], -[10061, 0.91303, 0.59081, 0.37839], -[10062, 0.80311, 0.55000, 0.00000], -[10063, 0.30311, 1.00000, 0.17500], -[10064, 0.12990, 1.00000, 0.07500], -[10065, 0.90566, 0.52142, 0.17517], -[10066, 0.57335, 0.93071, 0.44754], -[10067, 1.00000, 0.21854, 0.11250], -[10068, 0.81490, 0.73032, 0.47575], -[10069, 0.87269, 0.61784, 0.26608], -[10070, 0.73657, 0.80290, 0.39533], -[10071, 0.73497, 0.76077, 0.21850], -[10072, 0.52102, 0.87052, 0.08900], -[10073, 0.62959, 0.86536, 0.26970], -[10074, 0.80233, 0.74371, 0.46197], -[10075, 1.00000, 0.24019, 0.12500], -[10076, 0.50953, 0.94196, 0.27318], -[10077, 0.91401, 0.52842, 0.21054], -[10078, 0.91587, 0.59038, 0.39455], -[10079, 0.62623, 0.89766, 0.47647], -[10080, 0.85244, 0.54769, 0.08535], -[10081, 1.00000, 0.39175, 0.28750], -[10082, 0.86300, 0.60662, 0.20676], -[10083, 1.00000, 0.19689, 0.10000], -[10084, 0.60658, 0.84521, 0.15860], -[10085, 0.53698, 0.95024, 0.41290], -[10086, 0.73751, 0.78315, 0.29582], -[10087, 0.71253, 0.76784, 0.18100], -[10088, 0.74586, 0.80087, 0.46260], -[10089, 0.84218, 0.69235, 0.39734], -[10090, 0.89060, 0.58760, 0.25355], -[10091, 0.65716, 0.73945, 0.03039], -[10092, 0.89194, 0.62282, 0.37457], -[10093, 0.79589, 0.69330, 0.20821], -[10094, 0.94462, 0.55217, 0.45477], -[10095, 1.00000, 0.08864, 0.06250], -[10096, 0.63908, 0.84842, 0.23342], -[10097, 0.72605, 0.81402, 0.40231], -[10098, 0.55831, 0.91046, 0.25775], -[10099, 0.63294, 0.89226, 0.44884], -[10100, 0.61310, 0.86866, 0.23731], -[10101, 1.00000, 0.37010, 0.25000], -[10102, 0.51406, 0.92695, 0.22384], -[10103, 0.74297, 0.74188, 0.18797], -[10104, 0.57481, 0.86279, 0.14650], -[10105, 0.61628, 0.82531, 0.12738], -[10106, 0.75809, 0.73520, 0.20918], -[10107, 0.84065, 0.61050, 0.15302], -[10108, 0.86250, 0.67524, 0.50000], -[10109, 0.77595, 0.75181, 0.31953], -[10110, 0.75769, 0.64916, 0.04784], -[10111, 1.00000, 0.26184, 0.13750], -[10112, 0.84997, 0.62552, 0.20612], -[10113, 0.53944, 0.85786, 0.08376], -[10114, 0.85846, 0.67798, 0.44013], -[10115, 0.83067, 0.58317, 0.08756], -[10116, 0.78791, 0.71946, 0.25136], -[10117, 0.77022, 0.76426, 0.34825], -[10118, 0.74500, 0.78544, 0.33119], -[10119, 0.78294, 0.71293, 0.21862], -[10120, 0.83746, 0.69041, 0.35004], -[10121, 0.87088, 0.66436, 0.47367], -[10122, 0.76516, 0.61767, 0.01675], -[10123, 0.78750, 0.76184, 0.50000], -[10124, 0.97500, 0.00000, 0.00000], -[10125, 0.00000, 0.97500, 0.00000], -[10126, 0.50000, 0.97500, 0.50000], -[10127, 0.97500, 0.50000, 0.50000], -[10128, 0.84549, 0.56730, 0.09504], -[10129, 1.00000, 0.17524, 0.08750], -[10130, 0.70263, 0.82279, 0.32597], -[10131, 0.59694, 0.90785, 0.35668], -[10132, 0.51864, 0.96065, 0.40383], -[10133, 0.56906, 0.91121, 0.28308], -[10134, 0.69187, 0.84956, 0.47116], -[10135, 0.82853, 0.68405, 0.28348], -[10136, 0.73816, 0.63750, 0.00000], -[10137, 0.91437, 0.60415, 0.48406], -[10138, 0.74871, 0.72395, 0.15843], -[10139, 0.60825, 0.76250, 0.00000], -[10140, 1.00000, 0.41340, 0.32500], -[10141, 0.41340, 1.00000, 0.32500], -[10142, 0.71205, 0.80400, 0.28058], -[10143, 0.79129, 0.72918, 0.29086], -[10144, 0.88971, 0.50000, 0.10000], -[10145, 0.63750, 0.89175, 0.50000], -[10146, 0.65067, 0.84630, 0.25081], -[10147, 0.61833, 0.90439, 0.46022], -[10148, 0.53924, 0.84237, 0.05109], -[10149, 0.82990, 0.71621, 0.48592], -[10150, 0.43505, 1.00000, 0.38750], -[10151, 1.00000, 0.43505, 0.38750], -[10152, 0.77646, 0.77315, 0.46301], -[10153, 0.89195, 0.63451, 0.43776], -[10154, 0.80160, 0.74782, 0.48402], -[10155, 0.72359, 0.69521, 0.05820], -[10156, 0.63792, 0.82399, 0.15901], -[10157, 0.67544, 0.75668, 0.08357], -[10158, 0.77164, 0.67650, 0.11378], -[10159, 0.56720, 0.90298, 0.24475], -[10160, 0.77754, 0.66171, 0.10008], -[10161, 0.04330, 0.97500, 0.00000], -[10162, 0.38971, 1.00000, 0.27500], -[10163, 1.00000, 0.45000, 0.50000], -[10164, 0.45000, 1.00000, 0.50000], -[10165, 1.00000, 0.00000, 0.05000], -[10166, 0.00000, 1.00000, 0.05000], -[10167, 0.75294, 0.72785, 0.17470], -[10168, 0.88163, 0.63656, 0.35814], -[10169, 0.51909, 0.96376, 0.43354], -[10170, 0.85403, 0.67739, 0.37971], -[10171, 0.72773, 0.81216, 0.38345], -[10172, 1.00000, 0.28349, 0.15000], -[10173, 0.61784, 0.80888, 0.09137], -[10174, 0.82791, 0.54845, 0.03444], -[10175, 1.00000, 0.02369, 0.05000], -[10176, 0.32476, 1.00000, 0.18750], -[10177, 0.10825, 1.00000, 0.06250], -[10178, 0.83000, 0.62085, 0.14112], -[10179, 0.90374, 0.56296, 0.23616], -[10180, 0.53246, 0.83656, 0.03103], -[10181, 0.88971, 0.61117, 0.30422], -[10182, 0.53151, 0.95901, 0.46388], -[10183, 0.10604, 0.97072, 0.00000], -[10184, 0.81762, 0.71031, 0.32522], -[10185, 0.87307, 0.57161, 0.16138], -[10186, 0.89684, 0.61651, 0.36085], -[10187, 0.91127, 0.60988, 0.46249], -[10188, 0.97631, 0.50000, 0.47500], -[10189, 0.97631, 0.02500, 0.00000], -[10190, 0.60107, 0.91780, 0.48425], -[10191, 0.57510, 0.89299, 0.22482], -[10192, 0.73562, 0.68007, 0.05248], -[10193, 0.62300, 0.90032, 0.42742], -[10194, 0.59582, 0.91301, 0.37594], -[10195, 0.87410, 0.51619, 0.08344], -[10196, 0.34845, 0.91250, 0.00000], -[10197, 0.91250, 0.34845, 0.00000], -[10198, 1.00000, 0.34845, 0.21250], -[10199, 0.92936, 0.58057, 0.44229], -[10200, 0.77497, 0.63426, 0.05137], -[10201, 1.00000, 0.15359, 0.07500], -[10202, 0.57135, 0.92094, 0.32769], -[10203, 0.36806, 1.00000, 0.23750], -[10204, 0.04330, 1.00000, 0.05000], -[10205, 0.57241, 0.91589, 0.30531], -[10206, 0.80269, 0.74424, 0.42016], -[10207, 0.61649, 0.89618, 0.35365], -[10208, 0.59239, 0.92228, 0.44398], -[10209, 0.52887, 0.94034, 0.29809], -[10210, 0.56949, 0.88041, 0.17548], -[10211, 0.77555, 0.73347, 0.24445], -[10212, 0.80294, 0.57069, 0.01581], -[10213, 0.79055, 0.75273, 0.38444], -[10214, 0.66543, 0.81431, 0.18509], -[10215, 0.82791, 0.70754, 0.36198], -[10216, 0.51060, 0.94910, 0.29112], -[10217, 0.73211, 0.75936, 0.19579], -[10218, 0.75965, 0.79047, 0.44260], -[10219, 0.58127, 0.92481, 0.39001], -[10220, 0.50000, 0.95670, 0.30000], -[10221, 0.71435, 0.70842, 0.06045], -[10222, 0.55258, 0.82948, 0.03956], -[10223, 0.69486, 0.68750, 0.00000], -[10224, 0.81753, 0.54867, 0.01396], -[10225, 0.97631, 0.50000, 0.45000], -[10226, 0.97631, 0.05000, 0.00000], -[10227, 0.78146, 0.58750, 0.00000], -[10228, 0.69487, 0.78924, 0.18356], -[10229, 0.91647, 0.52006, 0.19094], -[10230, 0.84228, 0.69294, 0.37235], -[10231, 0.51337, 0.95624, 0.33236], -[10232, 0.56685, 0.92850, 0.34890], -[10233, 0.65457, 0.83604, 0.21910], -[10234, 0.83702, 0.70641, 0.41782], -[10235, 0.79476, 0.64788, 0.10634], -[10236, 0.95466, 0.50000, 0.28750], -[10237, 0.95466, 0.21250, 0.00000], -[10238, 0.64062, 0.87103, 0.30623], -[10239, 0.82666, 0.72093, 0.44056], -[10240, 0.65995, 0.86817, 0.36794], -[10241, 0.64951, 0.88541, 0.46957], -[10242, 0.67713, 0.86297, 0.44059], -[10243, 0.53937, 0.87069, 0.10280], -[10244, 0.50000, 0.91340, 0.15000], -[10245, 0.63112, 0.86275, 0.24658], -[10246, 0.23816, 1.00000, 0.11250], -[10247, 0.21651, 1.00000, 0.10000], -[10248, 0.80139, 0.74913, 0.44096], -[10249, 0.70355, 0.73521, 0.08596], -[10250, 0.50000, 0.93505, 0.21250], -[10251, 1.00000, 0.06699, 0.05000], -[10252, 0.54007, 0.87970, 0.12391], -[10253, 1.00000, 0.30514, 0.16250], -[10254, 0.62831, 0.89349, 0.38189], -[10255, 0.58538, 0.83690, 0.09504], -[10256, 0.77719, 0.77315, 0.42740], -[10257, 0.77145, 0.71450, 0.18151], -[10258, 0.68295, 0.85004, 0.36542], -[10259, 0.17524, 0.96250, 0.00000], -[10260, 0.81468, 0.72081, 0.34543], -[10261, 0.66710, 0.86781, 0.40478], -[10262, 0.90575, 0.61928, 0.44246], -[10263, 0.84777, 0.69701, 0.44800], -[10264, 0.67636, 0.83289, 0.26311], -[10265, 0.50000, 0.97779, 0.46458], -[10266, 0.90031, 0.52610, 0.15358], -[10267, 0.86214, 0.55496, 0.10482], -[10268, 0.72129, 0.77572, 0.20770], -[10269, 0.86774, 0.62936, 0.25833], -[10270, 0.89459, 0.57254, 0.21810], -[10271, 0.52457, 0.95424, 0.35231], -[10272, 0.65029, 0.87768, 0.37973], -[10273, 0.81782, 0.58631, 0.05822], -[10274, 0.60431, 0.90310, 0.33546], -[10275, 0.69455, 0.83166, 0.31602], -[10276, 0.52350, 0.94140, 0.28180], -[10277, 0.70308, 0.74743, 0.10618], -[10278, 0.90085, 0.62550, 0.42711], -[10279, 0.25981, 1.00000, 0.12500], -[10280, 0.19486, 1.00000, 0.08750], -[10281, 0.54686, 0.90409, 0.19717], -[10282, 0.93844, 0.55819, 0.37389], -[10283, 0.71324, 0.83539, 0.46052], -[10284, 0.85000, 0.69689, 0.50000], -[10285, 1.00000, 0.43505, 0.36250], -[10286, 0.43505, 1.00000, 0.36250], -[10287, 0.93221, 0.55118, 0.31194], -[10288, 0.90907, 0.58728, 0.30775], -[10289, 0.94468, 0.54043, 0.34577], -[10290, 0.55731, 0.86646, 0.11649], -[10291, 0.57380, 0.93757, 0.48546], -[10292, 0.80932, 0.58101, 0.03531], -[10293, 0.66700, 0.77393, 0.09416], -[10294, 0.68284, 0.79476, 0.16737], -[10295, 0.84254, 0.58675, 0.10689], -[10296, 0.67085, 0.87062, 0.47429], -[10297, 0.63583, 0.76214, 0.02718], -[10298, 0.61549, 0.90569, 0.40158], -[10299, 0.97631, 0.50000, 0.42500], -[10300, 0.97631, 0.07500, 0.00000], -[10301, 1.00000, 0.13194, 0.06250], -[10302, 0.69692, 0.84555, 0.40942], -[10303, 0.69487, 0.84417, 0.38424], -[10304, 0.58561, 0.80681, 0.03629], -[10305, 0.73292, 0.75223, 0.17455], -[10306, 0.88410, 0.53121, 0.11896], -[10307, 0.72921, 0.82157, 0.45171], -[10308, 0.78455, 0.60668, 0.02513], -[10309, 0.74147, 0.66689, 0.03673], -[10310, 0.81262, 0.68005, 0.20616], -[10311, 1.00000, 0.45670, 0.47500], -[10312, 0.45670, 1.00000, 0.47500], -[10313, 0.88366, 0.65310, 0.45742], -[10314, 0.72500, 0.82679, 0.50000], -[10315, 0.62990, 0.75000, 0.00000], -[10316, 0.57574, 0.82115, 0.04882], -[10317, 0.59379, 0.92275, 0.42640], -[10318, 0.81253, 0.73839, 0.43580], -[10319, 0.50000, 0.87010, 0.05000], -[10320, 0.52778, 0.88919, 0.12533], -[10321, 0.84401, 0.67773, 0.30518], -[10322, 0.58991, 0.91046, 0.31915], -[10323, 0.74144, 0.69181, 0.07408], -[10324, 0.92701, 0.53684, 0.25057], -[10325, 0.86851, 0.63942, 0.28413], -[10326, 0.75087, 0.64578, 0.02151], -[10327, 0.53587, 0.91979, 0.22314], -[10328, 1.00000, 0.39175, 0.26250], -[10329, 0.82130, 0.67378, 0.21462], -[10330, 0.90638, 0.54962, 0.20613], -[10331, 0.34641, 1.00000, 0.20000], -[10332, 0.08660, 1.00000, 0.05000], -[10333, 0.65079, 0.88685, 0.48864], -[10334, 0.24019, 0.95000, 0.00000], -[10335, 0.60449, 0.91842, 0.46311], -[10336, 0.68902, 0.76473, 0.11160], -[10337, 0.78956, 0.61730, 0.04618], -[10338, 0.68266, 0.82255, 0.23957], -[10339, 0.93301, 0.50000, 0.20000], -[10340, 0.59472, 0.85302, 0.14055], -[10341, 0.28146, 1.00000, 0.13750], -[10342, 0.17321, 1.00000, 0.07500], -[10343, 0.68758, 0.78205, 0.14455], -[10344, 0.94379, 0.53654, 0.32072], -[10345, 0.93762, 0.57453, 0.45945], -[10346, 0.83483, 0.64854, 0.19450], -[10347, 0.81715, 0.70391, 0.28166], -[10348, 1.00000, 0.41340, 0.30000], -[10349, 0.61557, 0.91047, 0.44400], -[10350, 0.83501, 0.53329, 0.02102], -[10351, 0.92343, 0.59348, 0.42171], -[10352, 0.82839, 0.69747, 0.30411], -[10353, 0.45670, 1.00000, 0.45000], -[10354, 0.50000, 0.97835, 0.43750], -[10355, 1.00000, 0.45670, 0.45000], -[10356, 0.60055, 0.84109, 0.12182], -[10357, 0.68247, 0.84601, 0.32768], -[10358, 0.88027, 0.63425, 0.31522], -[10359, 0.84918, 0.66464, 0.27982], -[10360, 0.56497, 0.94423, 0.47570], -[10361, 0.59262, 0.86329, 0.16099], -[10362, 0.65841, 0.80152, 0.13175], -[10363, 0.93042, 0.54177, 0.27115], -[10364, 0.51800, 0.91509, 0.17457], -[10365, 0.80553, 0.72981, 0.32638], -[10366, 0.84512, 0.63073, 0.18428], -[10367, 0.97373, 0.50937, 0.43591], -[10368, 0.75999, 0.71088, 0.14113], -[10369, 0.76568, 0.66105, 0.06578], -[10370, 0.89508, 0.63172, 0.39232], -[10371, 0.91136, 0.50000, 0.13750], -[10372, 0.78008, 0.74930, 0.29485], -[10373, 0.55628, 0.90948, 0.22518], -[10374, 0.96742, 0.52349, 0.45254], -[10375, 0.08693, 0.97708, 0.00000], -[10376, 0.80628, 0.61603, 0.07259], -[10377, 0.80837, 0.73450, 0.36069], -[10378, 0.69463, 0.81961, 0.25894], -[10379, 0.32679, 0.92500, 0.00000], -[10380, 1.00000, 0.32679, 0.17500], -[10381, 0.90019, 0.63286, 0.46012], -[10382, 0.94862, 0.51389, 0.27980], -[10383, 0.79531, 0.59180, 0.02066], -[10384, 0.68704, 0.81335, 0.21890], -[10385, 1.00000, 0.37010, 0.22500], -[10386, 0.90669, 0.61288, 0.37799], -[10387, 0.93499, 0.58148, 0.48164], -[10388, 0.67500, 0.87010, 0.50000], -[10389, 0.62391, 0.86389, 0.22194], -[10390, 0.56165, 0.94193, 0.39846], -[10391, 0.73595, 0.80748, 0.36084], -[10392, 0.60987, 0.82791, 0.10548], -[10393, 0.78793, 0.76750, 0.44394], -[10394, 0.58758, 0.93121, 0.47306], -[10395, 0.97631, 0.10000, 0.00000], -[10396, 0.72782, 0.82622, 0.47099], -[10397, 0.82320, 0.69237, 0.26275], -[10398, 0.68075, 0.74016, 0.05033], -[10399, 0.76644, 0.74452, 0.23220], -[10400, 0.81968, 0.60418, 0.07963], -[10401, 0.60465, 0.87491, 0.21265], -[10402, 0.78907, 0.76299, 0.40595], -[10403, 0.85316, 0.64032, 0.22468], -[10404, 0.60464, 0.80245, 0.04807], -[10405, 0.70497, 0.84323, 0.42408], -[10406, 0.73750, 0.74105, 0.15252], -[10407, 0.76354, 0.77469, 0.32485], -[10408, 0.95486, 0.53284, 0.36513], -[10409, 0.71209, 0.84066, 0.48394], -[10410, 0.64030, 0.88275, 0.34220], -[10411, 0.45670, 1.00000, 0.42500], -[10412, 1.00000, 0.45670, 0.42500], -[10413, 0.86313, 0.66944, 0.35459], -[10414, 0.55835, 0.94702, 0.42424], -[10415, 0.30311, 1.00000, 0.15000], -[10416, 0.41136, 1.00000, 0.28750], -[10417, 0.38971, 1.00000, 0.25000], -[10418, 0.15155, 1.00000, 0.06250], -[10419, 0.71961, 0.72050, 0.07869], -[10420, 0.77500, 0.78349, 0.50000], -[10421, 0.63558, 0.89538, 0.40574], -[10422, 0.66283, 0.85171, 0.27671], -[10423, 1.00000, 0.11029, 0.05000], -[10424, 0.72342, 0.82804, 0.42450], -[10425, 0.81575, 0.65802, 0.15897], -[10426, 0.71632, 0.82673, 0.36521], -[10427, 0.50000, 0.97835, 0.41250], -[10428, 0.64568, 0.86252, 0.26744], -[10429, 0.78598, 0.73788, 0.27028], -[10430, 0.95259, 0.52002, 0.30703], -[10431, 0.72538, 0.81204, 0.32825], -[10432, 0.76357, 0.76734, 0.29196], -[10433, 0.82717, 0.57103, 0.04741], -[10434, 0.75155, 0.80291, 0.42493], -[10435, 0.84194, 0.55558, 0.05542], -[10436, 0.65962, 0.75695, 0.04483], -[10437, 0.57098, 0.81579, 0.02700], -[10438, 0.64713, 0.74662, 0.01105], -[10439, 0.95766, 0.53862, 0.41013], -[10440, 0.91991, 0.60505, 0.44502], -[10441, 0.50000, 0.89175, 0.08750], -[10442, 0.58026, 0.88395, 0.18798], -[10443, 0.88670, 0.65284, 0.44411], -[10444, 0.43505, 1.00000, 0.33750], -[10445, 1.00000, 0.43505, 0.33750], -[10446, 0.82002, 0.71028, 0.30289], -[10447, 0.90190, 0.61272, 0.33588], -[10448, 0.83752, 0.66474, 0.23079], -[10449, 0.78667, 0.70199, 0.17717], -[10450, 0.50000, 0.95670, 0.27500], -[10451, 0.64112, 0.89698, 0.48255], -[10452, 0.67262, 0.80880, 0.16922], -[10453, 0.94744, 0.55737, 0.41208], -[10454, 0.90464, 0.62306, 0.40240], -[10455, 0.51546, 0.97384, 0.45481], -[10456, 0.71838, 0.74356, 0.11629], -[10457, 0.79410, 0.74134, 0.31014], -[10458, 0.87656, 0.66622, 0.43658], -[10459, 0.73677, 0.81641, 0.41703], -[10460, 0.02221, 1.00000, 0.03542], -[10461, 0.77566, 0.69302, 0.13334], -[10462, 0.66541, 0.86414, 0.33601], -[10463, 0.67838, 0.84238, 0.28393], -[10464, 0.92597, 0.56197, 0.29194], -[10465, 0.67880, 0.78357, 0.12338], -[10466, 0.86327, 0.68198, 0.41828], -[10467, 0.86055, 0.66767, 0.32474], -[10468, 0.73019, 0.68227, 0.03255], -[10469, 0.79231, 0.63204, 0.06416], -[10470, 0.87031, 0.60058, 0.18526], -[10471, 0.74417, 0.81206, 0.43706], -[10472, 0.87424, 0.66732, 0.41256], -[10473, 0.55493, 0.92614, 0.27284], -[10474, 0.74953, 0.77851, 0.27763], -[10475, 0.53120, 0.86284, 0.06318], -[10476, 0.71019, 0.82267, 0.30924], -[10477, 0.53751, 0.95750, 0.39113], -[10478, 0.51701, 0.90451, 0.13647], -[10479, 0.75079, 0.78571, 0.30872], -[10480, 0.96107, 0.54144, 0.47118], -[10481, 1.00000, 0.24019, 0.10000], -[10482, 0.83750, 0.71854, 0.50000], -[10483, 0.55000, 0.95670, 0.50000], -[10484, 0.95466, 0.50000, 0.26250], -[10485, 0.95466, 0.23750, 0.00000], -[10486, 0.68657, 0.71645, 0.01715], -[10487, 0.68919, 0.72806, 0.03872], -[10488, 0.91062, 0.60590, 0.35342], -[10489, 1.00000, 0.21854, 0.08750], -[10490, 0.75981, 0.62500, 0.00000], -[10491, 1.00000, 0.04611, 0.03542], -[10492, 0.71823, 0.75639, 0.13945], -[10493, 0.56356, 0.88129, 0.14822], -[10494, 0.65715, 0.81484, 0.15042], -[10495, 0.51532, 0.94398, 0.25229], -[10496, 0.57843, 0.87616, 0.15969], -[10497, 0.71489, 0.69632, 0.02871], -[10498, 0.85491, 0.61530, 0.17038], -[10499, 0.36806, 1.00000, 0.21250], -[10500, 0.60804, 0.91766, 0.41955], -[10501, 0.84962, 0.69890, 0.41058], -[10502, 0.70074, 0.77031, 0.13405], -[10503, 0.85975, 0.59377, 0.14413], -[10504, 0.82288, 0.61814, 0.10102], -[10505, 0.65155, 0.73750, 0.00000], -[10506, 0.61855, 0.88052, 0.25389], -[10507, 0.45670, 1.00000, 0.40000], -[10508, 1.00000, 0.45670, 0.40000], -[10509, 0.79117, 0.67615, 0.13189], -[10510, 1.00000, 0.26184, 0.11250], -[10511, 0.68443, 0.86237, 0.41882], -[10512, 0.51443, 0.85000, 0.01875], -[10513, 0.97631, 0.12500, 0.00000], -[10514, 0.92829, 0.58131, 0.36131], -[10515, 0.95293, 0.55715, 0.47930], -[10516, 0.79707, 0.76314, 0.46455], -[10517, 0.71651, 0.67500, 0.00000], -[10518, 1.00000, 0.34845, 0.18750], -[10519, 0.82476, 0.53750, 0.00000], -[10520, 0.81376, 0.70096, 0.24365], -[10521, 0.32476, 1.00000, 0.16250], -[10522, 0.12990, 1.00000, 0.05000], -[10523, 1.00000, 0.19689, 0.07500], -[10524, 0.92005, 0.56735, 0.27406], -[10525, 0.90145, 0.60129, 0.28717], -[10526, 0.58750, 0.93505, 0.50000], -[10527, 0.73544, 0.77909, 0.23234], -[10528, 0.75201, 0.75308, 0.20523], -[10529, 0.58406, 0.85703, 0.12061], -[10530, 0.64028, 0.87341, 0.28361], -[10531, 0.77525, 0.72859, 0.20374], -[10532, 0.93757, 0.30103, 0.00000], -[10533, 0.97036, 0.51818, 0.40184], -[10534, 0.75439, 0.80606, 0.46958], -[10535, 0.97835, 0.50000, 0.38750], -[10536, 0.50000, 0.97835, 0.38750], -[10537, 0.66637, 0.87319, 0.38454], -[10538, 0.80364, 0.63504, 0.08682], -[10539, 0.70310, 0.71201, 0.03246], -[10540, 0.80910, 0.65841, 0.13699], -[10541, 0.91786, 0.60692, 0.40372], -[10542, 0.64724, 0.88629, 0.37452], -[10543, 0.56550, 0.93866, 0.36092], -[10544, 0.93344, 0.56568, 0.32996], -[10545, 0.88609, 0.60814, 0.24433], -[10546, 0.82438, 0.66146, 0.17866], -[10547, 0.06670, 1.00000, 0.03527], -[10548, 0.89745, 0.56905, 0.19778], -[10549, 0.86979, 0.56693, 0.12232], -[10550, 0.85908, 0.58557, 0.12597], -[10551, 0.86703, 0.67737, 0.39881], -[10552, 0.74711, 0.77532, 0.25176], -[10553, 0.77247, 0.74993, 0.25127], -[10554, 1.00000, 0.28349, 0.12500], -[10555, 0.55589, 0.89860, 0.17669], -[10556, 0.78894, 0.71168, 0.19649], -[10557, 0.89561, 0.54469, 0.15033], -[10558, 0.85538, 0.69906, 0.47106], -[10559, 0.76185, 0.78541, 0.34509], -[10560, 0.70567, 0.73036, 0.06418], -[10561, 0.89850, 0.64316, 0.48024], -[10562, 0.86922, 0.50000, 0.03542], -[10563, 0.89365, 0.60667, 0.26597], -[10564, 0.77556, 0.78161, 0.40478], -[10565, 1.00000, 0.41340, 0.27500], -[10566, 0.61882, 0.80772, 0.06846], -[10567, 0.68509, 0.81390, 0.20035], -[10568, 0.86977, 0.51443, 0.05215], -[10569, 0.84152, 0.63178, 0.16163], -[10570, 0.67091, 0.86906, 0.37185], -[10571, 0.90081, 0.55399, 0.17833], -[10572, 0.96204, 0.51541, 0.32481], -[10573, 0.50000, 0.93505, 0.18750], -[10574, 0.30514, 0.93750, 0.00000], -[10575, 0.77702, 0.66309, 0.07740], -[10576, 0.77836, 0.70422, 0.15320], -[10577, 0.85500, 0.51490, 0.02468], -[10578, 1.00000, 0.17524, 0.06250], -[10579, 0.75515, 0.80610, 0.45408], -[10580, 0.76621, 0.69612, 0.11203], -[10581, 0.88971, 0.50000, 0.07500], -[10582, 0.62165, 0.91396, 0.47567], -[10583, 1.00000, 0.39175, 0.23750], -[10584, 0.85000, 0.50000, 0.00000], -[10585, 0.50000, 0.85000, 0.00000], -[10586, 0.83329, 0.68086, 0.24563], -[10587, 0.59303, 0.92857, 0.40631], -[10588, 0.47835, 0.86250, 0.00000], -[10589, 0.86250, 0.47835, 0.00000], -[10590, 0.75416, 0.69788, 0.09139], -[10591, 0.93154, 0.58641, 0.39446], -[10592, 0.56088, 0.93446, 0.31236], -[10593, 0.61547, 0.90016, 0.31560], -[10594, 0.73886, 0.71587, 0.09396], -[10595, 0.62281, 0.88609, 0.27575], -[10596, 0.79549, 0.74983, 0.33143], -[10597, 0.71644, 0.83475, 0.38423], -[10598, 0.52165, 0.83750, 0.00000], -[10599, 0.84755, 0.61260, 0.13924], -[10600, 0.66888, 0.87798, 0.42529], -[10601, 0.60817, 0.87178, 0.19338], -[10602, 0.69917, 0.80150, 0.19552], -[10603, 0.95000, 0.56699, 0.50000], -[10604, 0.65084, 0.89180, 0.42858], -[10605, 0.52827, 0.95432, 0.31499], -[10606, 0.76001, 0.79826, 0.40412], -[10607, 0.45670, 0.87500, 0.00000], -[10608, 0.45670, 1.00000, 0.37500], -[10609, 1.00000, 0.45670, 0.37500], -[10610, 0.87500, 0.45670, 0.00000], -[10611, 0.15359, 0.97500, 0.00000], -[10612, 0.71453, 0.80866, 0.25558], -[10613, 0.80769, 0.60384, 0.04470], -[10614, 0.65803, 0.87575, 0.34379], -[10615, 0.65806, 0.77353, 0.06065], -[10616, 1.00000, 0.43505, 0.31250], -[10617, 0.43505, 1.00000, 0.31250], -[10618, 0.92976, 0.53472, 0.22786], -[10619, 0.54936, 0.83021, 0.01683], -[10620, 1.00000, 0.30514, 0.13750], -[10621, 0.56845, 0.89692, 0.18860], -[10622, 0.88750, 0.66081, 0.48125], -[10623, 0.82366, 0.73778, 0.45588], -[10624, 0.54735, 0.89069, 0.13699], -[10625, 0.88668, 0.65701, 0.41636], -[10626, 0.97500, 0.52369, 0.50000], -[10627, 0.50000, 0.91340, 0.12500], -[10628, 0.62500, 0.91340, 0.50000], -[10629, 0.77609, 0.78715, 0.44482], -[10630, 0.70883, 0.82025, 0.27698], -[10631, 0.67212, 0.82884, 0.20616], -[10632, 0.85119, 0.66370, 0.25492], -[10633, 0.96236, 0.54391, 0.44344], -[10634, 0.67256, 0.87760, 0.44753], -[10635, 0.68344, 0.84873, 0.30541], -[10636, 0.73702, 0.73030, 0.11430], -[10637, 0.69858, 0.85627, 0.43585], -[10638, 0.72898, 0.79642, 0.25567], -[10639, 0.93750, 0.58864, 0.50000], -[10640, 0.53760, 0.93860, 0.26438], -[10641, 0.75619, 0.68231, 0.06623], -[10642, 0.51295, 0.97204, 0.36727], -[10643, 0.80311, 0.57500, 0.00000], -[10644, 0.34641, 1.00000, 0.17500], -[10645, 0.41136, 1.00000, 0.26250], -[10646, 1.00000, 0.47500, 0.50000], -[10647, 0.47500, 1.00000, 0.50000], -[10648, 1.00000, 0.00000, 0.02500], -[10649, 0.00000, 1.00000, 0.02500], -[10650, 0.97631, 0.15000, 0.00000], -[10651, 0.88571, 0.58449, 0.18443], -[10652, 0.64692, 0.83926, 0.17930], -[10653, 0.59533, 0.79928, 0.01781], -[10654, 0.54330, 0.82500, 0.00000], -[10655, 0.68743, 0.86165, 0.39607], -[10656, 0.80421, 0.67611, 0.15079], -[10657, 0.83767, 0.57554, 0.06078], -[10658, 0.82758, 0.62991, 0.12016], -[10659, 0.56475, 0.84351, 0.05777], -[10660, 0.70809, 0.84064, 0.36580], -[10661, 0.97835, 0.50000, 0.36250], -[10662, 0.50000, 0.97835, 0.36250], -[10663, 1.00000, 0.15359, 0.05000], -[10664, 0.93301, 0.50000, 0.17500], -[10665, 0.93301, 0.32500, 0.00000], -[10666, 0.76804, 0.78928, 0.38459], -[10667, 1.00000, 0.02369, 0.02500], -[10668, 0.69310, 0.75995, 0.08978], -[10669, 0.97065, 0.51688, 0.36994], -[10670, 0.81396, 0.64837, 0.12133], -[10671, 0.61634, 0.84576, 0.13782], -[10672, 0.85765, 0.68193, 0.33939], -[10673, 0.78144, 0.73496, 0.22490], -[10674, 0.60692, 0.82373, 0.07617], -[10675, 0.62190, 0.77855, 0.01666], -[10676, 0.65781, 0.86497, 0.28634], -[10677, 0.94556, 0.54401, 0.30865], -[10678, 0.58646, 0.83493, 0.06913], -[10679, 0.88184, 0.65627, 0.36429], -[10680, 0.79793, 0.75418, 0.35385], -[10681, 0.90861, 0.58934, 0.26769], -[10682, 0.23816, 1.00000, 0.08750], -[10683, 0.43505, 0.88750, 0.00000], -[10684, 0.88750, 0.43505, 0.00000], -[10685, 1.00000, 0.37010, 0.20000], -[10686, 0.74964, 0.73000, 0.13619], -[10687, 0.10688, 1.00000, 0.03542], -[10688, 0.52628, 0.88946, 0.10087], -[10689, 0.88452, 0.53118, 0.09637], -[10690, 0.89880, 0.53287, 0.13169], -[10691, 0.38971, 1.00000, 0.22500], -[10692, 0.25981, 1.00000, 0.10000], -[10693, 0.21651, 1.00000, 0.07500], -[10694, 0.04330, 1.00000, 0.02500], -[10695, 0.71250, 0.84845, 0.50000], -[10696, 0.84137, 0.61081, 0.11714], -[10697, 0.86773, 0.65732, 0.29374], -[10698, 0.69800, 0.83543, 0.29363], -[10699, 0.61283, 0.86287, 0.17188], -[10700, 0.50000, 0.95670, 0.25000], -[10701, 0.56957, 0.87415, 0.12682], -[10702, 0.92500, 0.61029, 0.50000], -[10703, 0.83485, 0.71107, 0.34037], -[10704, 0.87354, 0.53912, 0.08234], -[10705, 0.80505, 0.75357, 0.38903], -[10706, 0.82976, 0.73008, 0.41750], -[10707, 0.88600, 0.55121, 0.12650], -[10708, 0.57459, 0.86338, 0.10914], -[10709, 0.66747, 0.86590, 0.31817], -[10710, 1.00000, 0.08831, 0.03036], -[10711, 0.85702, 0.69957, 0.43244], -[10712, 0.82500, 0.74019, 0.50000], -[10713, 0.94010, 0.58637, 0.46968], -[10714, 0.81225, 0.72847, 0.30446], -[10715, 0.21962, 0.96458, 0.00000], -[10716, 0.55366, 0.95219, 0.37569], -[10717, 0.97246, 0.52539, 0.41669], -[10718, 0.96458, 0.54611, 0.50000], -[10719, 0.88283, 0.60977, 0.22166], -[10720, 0.75685, 0.79833, 0.36340], -[10721, 0.67321, 0.72500, 0.00000], -[10722, 0.63326, 0.90835, 0.44742], -[10723, 0.81865, 0.67747, 0.18416], -[10724, 0.72434, 0.76679, 0.15899], -[10725, 0.53428, 0.96248, 0.36894], -[10726, 0.87517, 0.57892, 0.14220], -[10727, 0.86109, 0.54561, 0.06417], -[10728, 0.52740, 0.85818, 0.03688], -[10729, 0.67583, 0.83563, 0.22777], -[10730, 0.57860, 0.91666, 0.26738], -[10731, 1.00000, 0.32679, 0.15000], -[10732, 0.56495, 0.81250, 0.00000], -[10733, 0.28146, 1.00000, 0.11250], -[10734, 0.19486, 1.00000, 0.06250], -[10735, 1.00000, 0.47779, 0.46458], -[10736, 0.47779, 1.00000, 0.46458], -[10737, 0.89684, 0.59367, 0.23011], -[10738, 0.61819, 0.79240, 0.03141], -[10739, 0.76250, 0.80514, 0.50000], -[10740, 0.85028, 0.65125, 0.21258], -[10741, 0.82444, 0.56836, 0.02353], -[10742, 0.64032, 0.90477, 0.46516], -[10743, 0.55453, 0.92725, 0.24991], -[10744, 0.97934, 0.51388, 0.41836], -[10745, 0.55334, 0.96048, 0.46434], -[10746, 0.71403, 0.79771, 0.21051], -[10747, 0.93756, 0.57943, 0.37616], -[10748, 1.00000, 0.06699, 0.02500], -[10749, 0.92343, 0.60980, 0.42467], -[10750, 0.95466, 0.50000, 0.23750], -[10751, 0.95466, 0.26250, 0.00000], -[10752, 0.80891, 0.69425, 0.19330], -[10753, 0.79833, 0.69481, 0.16785], -[10754, 0.68982, 0.80969, 0.18519], -[10755, 0.63659, 0.79530, 0.06089], -[10756, 0.91136, 0.50000, 0.11250], -[10757, 0.88771, 0.65623, 0.38946], -[10758, 0.41340, 0.90000, 0.00000], -[10759, 0.90000, 0.41340, 0.00000], -[10760, 0.82836, 0.64361, 0.13858], -[10761, 0.80538, 0.76304, 0.48596], -[10762, 0.45670, 1.00000, 0.35000], -[10763, 1.00000, 0.45670, 0.35000], -[10764, 0.78236, 0.65238, 0.06009], -[10765, 0.67663, 0.84268, 0.24838], -[10766, 0.53617, 0.96997, 0.44523], -[10767, 0.83252, 0.66989, 0.20082], -[10768, 0.86187, 0.68475, 0.35970], -[10769, 0.54596, 0.96351, 0.42936], -[10770, 0.90351, 0.51412, 0.11169], -[10771, 0.89571, 0.65107, 0.42730], -[10772, 0.85185, 0.56898, 0.07325], -[10773, 0.75365, 0.74421, 0.16878], -[10774, 0.84350, 0.68219, 0.26616], -[10775, 0.82779, 0.68445, 0.22054], -[10776, 0.82244, 0.73535, 0.37842], -[10777, 0.56695, 0.95276, 0.44752], -[10778, 0.59467, 0.92344, 0.33998], -[10779, 0.91250, 0.63194, 0.50000], -[10780, 0.86555, 0.62175, 0.18968], -[10781, 0.56626, 0.86113, 0.08786], -[10782, 0.89469, 0.64502, 0.37507], -[10783, 0.88042, 0.67461, 0.45596], -[10784, 0.71069, 0.76043, 0.11419], -[10785, 0.92497, 0.55449, 0.23697], -[10786, 0.88822, 0.56564, 0.14878], -[10787, 0.14885, 1.00000, 0.04159], -[10788, 0.65573, 0.89436, 0.44936], -[10789, 0.79928, 0.72225, 0.23179], -[10790, 0.63203, 0.86214, 0.20053], -[10791, 0.68041, 0.75569, 0.05451], -[10792, 0.30311, 1.00000, 0.12500], -[10793, 0.17036, 1.00000, 0.04881], -[10794, 0.84936, 0.54059, 0.03206], -[10795, 0.96635, 0.52590, 0.35096], -[10796, 0.94285, 0.57984, 0.41333], -[10797, 0.50000, 0.87010, 0.02500], -[10798, 1.00000, 0.47835, 0.43750], -[10799, 0.47835, 1.00000, 0.43750], -[10800, 0.77216, 0.68474, 0.09058], -[10801, 0.88472, 0.65152, 0.34012], -[10802, 0.28349, 0.95000, 0.00000], -[10803, 0.91371, 0.51644, 0.13763], -[10804, 1.00000, 0.13078, 0.03542], -[10805, 0.96674, 0.53399, 0.38474], -[10806, 0.56989, 0.89406, 0.16998], -[10807, 0.78566, 0.76842, 0.34066], -[10808, 0.36806, 1.00000, 0.18750], -[10809, 0.71977, 0.78718, 0.19106], -[10810, 0.66116, 0.85164, 0.23400], -[10811, 0.53674, 0.91145, 0.16182], -[10812, 0.92044, 0.53916, 0.19129], -[10813, 0.94501, 0.54775, 0.29953], -[10814, 0.94436, 0.52442, 0.24225], -[10815, 0.87984, 0.55023, 0.10440], -[10816, 1.00000, 0.41340, 0.25000], -[10817, 0.63812, 0.80656, 0.08085], -[10818, 0.87670, 0.65522, 0.31149], -[10819, 0.63202, 0.78655, 0.03591], -[10820, 0.76593, 0.74064, 0.18643], -[10821, 0.52345, 0.97930, 0.47645], -[10822, 0.97835, 0.50000, 0.33750], -[10823, 0.50000, 0.97835, 0.33750], -[10824, 0.52222, 0.92897, 0.18701], -[10825, 0.63245, 0.82481, 0.10832], -[10826, 0.81371, 0.72534, 0.28670], -[10827, 0.73816, 0.66250, 0.00000], -[10828, 0.97631, 0.17500, 0.00000], -[10829, 0.59999, 0.82003, 0.05116], -[10830, 0.55312, 0.95095, 0.34602], -[10831, 0.77723, 0.78151, 0.36169], -[10832, 0.08704, 1.00000, 0.02414], -[10833, 0.68059, 0.78577, 0.10837], -[10834, 0.80118, 0.76588, 0.42525], -[10835, 0.74956, 0.80464, 0.34256], -[10836, 0.58660, 0.80000, 0.00000], -[10837, 0.66250, 0.89175, 0.50000], -[10838, 0.77826, 0.63440, 0.02461], -[10839, 0.77030, 0.64884, 0.03114], -[10840, 0.84101, 0.69695, 0.29686], -[10841, 0.51757, 0.91943, 0.15203], -[10842, 1.00000, 0.43505, 0.28750], -[10843, 0.43505, 1.00000, 0.28750], -[10844, 0.72713, 0.73561, 0.09426], -[10845, 0.66282, 0.79611, 0.09816], -[10846, 0.59731, 0.89404, 0.21974], -[10847, 0.89459, 0.62308, 0.28519], -[10848, 0.60560, 0.90915, 0.29667], -[10849, 0.51152, 0.98634, 0.48680], -[10850, 0.91586, 0.60172, 0.31597], -[10851, 0.63609, 0.83455, 0.13442], -[10852, 0.83883, 0.60410, 0.09231], -[10853, 0.73707, 0.82492, 0.39489], -[10854, 0.79132, 0.77989, 0.47917], -[10855, 0.66006, 0.78766, 0.07718], -[10856, 0.63926, 0.89066, 0.31844], -[10857, 0.65978, 0.88940, 0.40757], -[10858, 0.94779, 0.57024, 0.39306], -[10859, 0.54629, 0.94356, 0.28505], -[10860, 0.89851, 0.63463, 0.34207], -[10861, 0.92959, 0.57804, 0.30820], -[10862, 0.65840, 0.83096, 0.16672], -[10863, 1.00000, 0.34845, 0.16250], -[10864, 0.86343, 0.57760, 0.10477], -[10865, 0.79619, 0.67047, 0.11021], -[10866, 0.67133, 0.88521, 0.46423], -[10867, 0.81272, 0.70199, 0.21294], -[10868, 0.84916, 0.71698, 0.47509], -[10869, 0.87486, 0.53103, 0.06594], -[10870, 0.58952, 0.90839, 0.24880], -[10871, 0.78146, 0.61250, 0.00000], -[10872, 0.86850, 0.65322, 0.26577], -[10873, 0.91119, 0.54219, 0.16584], -[10874, 0.62680, 0.85037, 0.15364], -[10875, 0.72399, 0.84345, 0.47876], -[10876, 0.74872, 0.81297, 0.37912], -[10877, 0.39175, 0.91250, 0.00000], -[10878, 0.91250, 0.39175, 0.00000], -[10879, 1.00000, 0.39175, 0.21250], -[10880, 0.66845, 0.88832, 0.48169], -[10881, 0.50851, 0.94216, 0.19984], -[10882, 0.65123, 0.84961, 0.19925], -[10883, 0.72046, 0.84493, 0.44093], -[10884, 1.00000, 0.47835, 0.41250], -[10885, 0.47835, 1.00000, 0.41250], -[10886, 0.58181, 0.90023, 0.20410], -[10887, 0.86660, 0.69527, 0.45286], -[10888, 0.50000, 0.89175, 0.06250], -[10889, 0.87405, 0.68710, 0.47299], -[10890, 0.65877, 0.89571, 0.47678], -[10891, 0.78805, 0.63901, 0.04452], -[10892, 0.32476, 1.00000, 0.13750], -[10893, 0.95300, 0.56919, 0.43097], -[10894, 0.60218, 0.90524, 0.26557], -[10895, 0.93521, 0.58203, 0.34598], -[10896, 0.84289, 0.71530, 0.37755], -[10897, 0.90000, 0.65359, 0.50000], -[10898, 0.76041, 0.67401, 0.04757], -[10899, 0.67698, 0.74949, 0.03392], -[10900, 0.63164, 0.89351, 0.29986], -[10901, 0.54940, 0.95103, 0.32336], -[10902, 0.53876, 0.92020, 0.18296], -[10903, 0.79140, 0.73918, 0.24517], -[10904, 0.54322, 0.97070, 0.48224], -[10905, 0.91002, 0.62451, 0.36008], -[10906, 0.72209, 0.71513, 0.04720], -[10907, 0.72220, 0.84037, 0.39967], -[10908, 0.86449, 0.65136, 0.24252], -[10909, 0.62725, 0.90400, 0.33493], -[10910, 0.87237, 0.62717, 0.21092], -[10911, 0.74010, 0.67460, 0.01514], -[10912, 0.71580, 0.83760, 0.34499], -[10913, 0.41136, 1.00000, 0.23750], -[10914, 0.50000, 0.93505, 0.16250], -[10915, 0.62040, 0.88107, 0.22241], -[10916, 0.56281, 0.91585, 0.21241], -[10917, 1.00000, 0.24019, 0.07500], -[10918, 0.92214, 0.52094, 0.15852], -[10919, 0.64705, 0.81117, 0.09792], -[10920, 0.91994, 0.57346, 0.24857], -[10921, 0.80566, 0.72995, 0.26239], -[10922, 0.98048, 0.52578, 0.47189], -[10923, 0.65382, 0.81291, 0.11234], -[10924, 0.59192, 0.91700, 0.28243], -[10925, 0.97918, 0.52494, 0.43475], -[10926, 0.84213, 0.72596, 0.45081], -[10927, 0.51638, 0.98234, 0.41605], -[10928, 0.72779, 0.81976, 0.30762], -[10929, 1.00000, 0.26184, 0.08750], -[10930, 0.54337, 0.92545, 0.20483], -[10931, 0.63752, 0.88130, 0.26385], -[10932, 0.74454, 0.80690, 0.31667], -[10933, 0.52835, 0.93523, 0.20789], -[10934, 1.00000, 0.21854, 0.06250], -[10935, 1.00000, 0.45670, 0.32500], -[10936, 0.45670, 1.00000, 0.32500], -[10937, 0.64646, 0.86139, 0.21838], -[10938, 0.19689, 0.97500, 0.00000], -[10939, 0.60854, 0.93175, 0.46961], -[10940, 0.70009, 0.75129, 0.06994], -[10941, 0.65018, 0.89680, 0.38807], -[10942, 0.73689, 0.74774, 0.12923], -[10943, 0.52415, 0.97583, 0.38750], -[10944, 1.00000, 0.11088, 0.02315], -[10945, 0.86182, 0.54030, 0.04715], -[10946, 0.69425, 0.80042, 0.15752], -[10947, 0.60825, 0.78750, 0.00000], -[10948, 0.95660, 0.51728, 0.26023], -[10949, 0.96336, 0.53357, 0.33445], -[10950, 1.00000, 0.28349, 0.10000], -[10951, 0.90513, 0.61625, 0.29642], -[10952, 0.69486, 0.71250, 0.00000], -[10953, 0.81250, 0.76184, 0.50000], -[10954, 0.57544, 0.94608, 0.37986], -[10955, 0.56368, 0.96061, 0.48484], -[10956, 0.53102, 0.94119, 0.22991], -[10957, 0.71722, 0.80857, 0.23037], -[10958, 0.50000, 0.95670, 0.22500], -[10959, 0.70560, 0.82163, 0.23887], -[10960, 0.83745, 0.73427, 0.47391], -[10961, 0.69793, 0.77713, 0.11243], -[10962, 0.66903, 0.88434, 0.39234], -[10963, 1.00000, 0.19689, 0.05000], -[10964, 0.94998, 0.56359, 0.35445], -[10965, 0.54802, 0.94933, 0.30050], -[10966, 0.80697, 0.76278, 0.40859], -[10967, 0.70053, 0.86629, 0.48426], -[10968, 0.75089, 0.82212, 0.45821], -[10969, 0.93670, 0.52582, 0.20408], -[10970, 0.77597, 0.79904, 0.47025], -[10971, 0.47835, 1.00000, 0.38750], -[10972, 1.00000, 0.47835, 0.38750], -[10973, 0.52121, 0.98315, 0.44290], -[10974, 0.81471, 0.74356, 0.34231], -[10975, 0.51713, 0.97482, 0.34533], -[10976, 0.69184, 0.87267, 0.46245], -[10977, 0.60053, 0.88861, 0.19770], -[10978, 0.68266, 0.86720, 0.34620], -[10979, 0.38971, 1.00000, 0.20000], -[10980, 0.84641, 0.52500, 0.00000], -[10981, 0.67029, 0.83365, 0.18729], -[10982, 0.84118, 0.59213, 0.07112], -[10983, 0.91913, 0.56320, 0.21668], -[10984, 0.62899, 0.91592, 0.41216], -[10985, 0.69705, 0.83903, 0.27097], -[10986, 0.93402, 0.55766, 0.25723], -[10987, 0.50000, 0.97835, 0.31250], -[10988, 0.97835, 0.50000, 0.31250], -[10989, 0.51025, 0.99018, 0.46053], -[10990, 0.52506, 0.95691, 0.27413], -[10991, 0.34641, 1.00000, 0.15000], -[10992, 0.12990, 1.00000, 0.02500], -[10993, 0.71694, 0.78644, 0.16828], -[10994, 0.73990, 0.71039, 0.06358], -[10995, 0.37010, 0.92500, 0.00000], -[10996, 0.92500, 0.37010, 0.00000], -[10997, 1.00000, 0.37010, 0.17500], -[10998, 0.52206, 0.88380, 0.06531], -[10999, 0.70849, 0.85378, 0.39137], -[11000, 0.56942, 0.94347, 0.33168], -[11001, 0.53542, 0.97779, 0.50000], -[11002, 0.82268, 0.75186, 0.47399], -[11003, 0.55654, 0.96165, 0.40906], -[11004, 0.86620, 0.56606, 0.08521], -[11005, 0.53669, 0.97309, 0.41065], -[11006, 0.67340, 0.86361, 0.29110], -[11007, 0.89028, 0.64019, 0.29879], -[11008, 0.93750, 0.60307, 0.48125], -[11009, 0.57130, 0.93450, 0.29190], -[11010, 0.76910, 0.64221, 0.01109], -[11011, 0.93301, 0.50000, 0.15000], -[11012, 0.73419, 0.77489, 0.17809], -[11013, 0.87921, 0.67348, 0.37131], -[11014, 0.84427, 0.65110, 0.17372], -[11015, 0.97631, 0.20000, 0.00000], -[11016, 0.83936, 0.71104, 0.31786], -[11017, 1.00000, 0.30514, 0.11250], -[11018, 0.53584, 0.90759, 0.13604], -[11019, 0.60883, 0.89451, 0.23072], -[11020, 0.77321, 0.75068, 0.21370], -[11021, 0.56973, 0.83763, 0.03399], -[11022, 0.58353, 0.94783, 0.43242], -[11023, 0.52262, 0.87355, 0.04477], -[11024, 0.81973, 0.67897, 0.16747], -[11025, 0.92842, 0.54627, 0.21162], -[11026, 0.64856, 0.77469, 0.02799], -[11027, 0.88750, 0.67524, 0.50000], -[11028, 0.71925, 0.83386, 0.32396], -[11029, 0.85326, 0.58717, 0.08659], -[11030, 0.53464, 0.96465, 0.33448], -[11031, 0.66045, 0.76355, 0.02609], -[11032, 0.62803, 0.91901, 0.43068], -[11033, 0.67759, 0.80991, 0.14119], -[11034, 0.79750, 0.66239, 0.08876], -[11035, 0.95466, 0.50000, 0.21250], -[11036, 0.95466, 0.28750, 0.00000], -[11037, 0.92198, 0.62622, 0.45709], -[11038, 0.75832, 0.71685, 0.10612], -[11039, 0.88971, 0.50000, 0.05000], -[11040, 0.58787, 0.94689, 0.45495], -[11041, 0.50000, 0.91340, 0.10000], -[11042, 0.71188, 0.83253, 0.28907], -[11043, 0.60056, 0.94002, 0.48866], -[11044, 0.82187, 0.71511, 0.25982], -[11045, 0.71315, 0.85727, 0.46733], -[11046, 0.76669, 0.73110, 0.15031], -[11047, 1.00000, 0.17524, 0.03750], -[11048, 0.75178, 0.76134, 0.18396], -[11049, 0.58982, 0.81291, 0.01420], -[11050, 0.84498, 0.56007, 0.03409], -[11051, 0.94709, 0.53930, 0.26133], -[11052, 0.70748, 0.70876, 0.00809], -[11053, 0.85033, 0.70808, 0.35707], -[11054, 0.86303, 0.51207, 0.01224], -[11055, 0.77197, 0.73296, 0.16564], -[11056, 0.65216, 0.86760, 0.24080], -[11057, 0.78608, 0.76001, 0.27704], -[11058, 0.73311, 0.82645, 0.34249], -[11059, 0.78813, 0.71683, 0.16787], -[11060, 0.61549, 0.91850, 0.34831], -[11061, 0.66393, 0.86232, 0.25272], -[11062, 0.84726, 0.72317, 0.43066], -[11063, 0.96345, 0.55372, 0.39604], -[11064, 0.59995, 0.93363, 0.38145], -[11065, 1.00000, 0.43505, 0.26250], -[11066, 0.91248, 0.58289, 0.22911], -[11067, 0.57500, 0.95670, 0.50000], -[11068, 0.88397, 0.61150, 0.19879], -[11069, 0.75000, 0.82679, 0.50000], -[11070, 0.59936, 0.88396, 0.17524], -[11071, 0.69764, 0.86108, 0.36603], -[11072, 0.73600, 0.82903, 0.36876], -[11073, 0.58369, 0.94159, 0.36214], -[11074, 0.83994, 0.55343, 0.01552], -[11075, 1.00000, 0.41340, 0.22500], -[11076, 0.58029, 0.95367, 0.48270], -[11077, 0.88016, 0.66847, 0.34159], -[11078, 0.82476, 0.56250, 0.00000], -[11079, 0.61214, 0.86534, 0.14906], -[11080, 0.93296, 0.52345, 0.18012], -[11081, 0.81474, 0.75073, 0.36061], -[11082, 0.82467, 0.74674, 0.40406], -[11083, 0.92887, 0.60726, 0.37600], -[11084, 0.91250, 0.64113, 0.44279], -[11085, 0.70000, 0.87010, 0.50000], -[11086, 0.79668, 0.69598, 0.14209], -[11087, 0.95392, 0.55298, 0.32265], -[11088, 0.57491, 0.92277, 0.24471], -[11089, 0.59308, 0.87590, 0.14180], -[11090, 0.93556, 0.34934, 0.00000], -[11091, 0.85483, 0.68609, 0.28575], -[11092, 0.62990, 0.77500, 0.00000], -[11093, 1.00000, 0.32679, 0.12500], -[11094, 0.88359, 0.67560, 0.39852], -[11095, 0.77142, 0.77483, 0.27173], -[11096, 0.62249, 0.84412, 0.11576], -[11097, 0.85686, 0.71501, 0.45272], -[11098, 0.91294, 0.63172, 0.37692], -[11099, 0.62405, 0.80761, 0.04610], -[11100, 0.47835, 1.00000, 0.36250], -[11101, 1.00000, 0.47835, 0.36250], -[11102, 0.55115, 0.84972, 0.02881], -[11103, 0.61785, 0.92202, 0.37295], -[11104, 0.58381, 0.93405, 0.31354], -[11105, 0.76046, 0.76885, 0.21960], -[11106, 0.23816, 1.00000, 0.06250], -[11107, 0.25981, 1.00000, 0.07500], -[11108, 0.82828, 0.73020, 0.32949], -[11109, 0.82327, 0.64108, 0.10055], -[11110, 0.60566, 0.85010, 0.10133], -[11111, 0.83924, 0.70273, 0.27550], -[11112, 1.00000, 0.45670, 0.30000], -[11113, 0.45670, 1.00000, 0.30000], -[11114, 0.96521, 0.56149, 0.45788], -[11115, 0.83435, 0.72807, 0.34995], -[11116, 0.63464, 0.91336, 0.39149], -[11117, 0.67235, 0.87604, 0.32857], -[11118, 0.78903, 0.76841, 0.31055], -[11119, 0.74759, 0.77528, 0.20171], -[11120, 0.93649, 0.60850, 0.45873], -[11121, 0.87874, 0.68745, 0.43501], -[11122, 0.62482, 0.90622, 0.30661], -[11123, 0.91523, 0.60670, 0.29152], -[11124, 0.85406, 0.70224, 0.33676], -[11125, 1.00000, 0.15359, 0.02500], -[11126, 0.28146, 1.00000, 0.08750], -[11127, 0.36806, 1.00000, 0.16250], -[11128, 0.61250, 0.93505, 0.50000], -[11129, 0.57767, 0.95282, 0.41078], -[11130, 0.76350, 0.79764, 0.32572], -[11131, 0.79416, 0.77519, 0.36596], -[11132, 0.90781, 0.60195, 0.24851], -[11133, 0.76170, 0.66357, 0.02126], -[11134, 0.92302, 0.59437, 0.28907], -[11135, 0.72570, 0.81979, 0.27403], -[11136, 0.82741, 0.59144, 0.03590], -[11137, 0.75981, 0.65000, 0.00000], -[11138, 0.64359, 0.85064, 0.16508], -[11139, 0.43301, 1.00000, 0.25000], -[11140, 1.00000, 0.00000, 0.00000], -[11141, 0.00000, 1.00000, 0.00000], -[11142, 1.00000, 0.50000, 0.50000], -[11143, 0.50000, 1.00000, 0.50000], -[11144, 0.68427, 0.73917, 0.01475], -[11145, 0.65159, 0.83658, 0.14552], -[11146, 0.90348, 0.57312, 0.17544], -[11147, 0.66918, 0.88475, 0.36002], -[11148, 0.58839, 0.88781, 0.15973], -[11149, 0.84890, 0.72190, 0.40779], -[11150, 0.90297, 0.65797, 0.45535], -[11151, 0.34845, 0.93750, 0.00000], -[11152, 0.96895, 0.55229, 0.41829], -[11153, 0.78008, 0.71975, 0.14778], -[11154, 1.00000, 0.02500, 0.00000], -[11155, 0.02500, 1.00000, 0.00000], -[11156, 1.00000, 0.50000, 0.47500], -[11157, 0.50000, 1.00000, 0.47500], -[11158, 0.51602, 0.97655, 0.32473], -[11159, 0.79740, 0.72840, 0.20975], -[11160, 0.67849, 0.85896, 0.27082], -[11161, 0.91136, 0.50000, 0.08750], -[11162, 0.82213, 0.75421, 0.42220], -[11163, 0.88200, 0.59597, 0.15685], -[11164, 0.74804, 0.80277, 0.28346], -[11165, 1.00000, 0.39175, 0.18750], -[11166, 0.70194, 0.86633, 0.41116], -[11167, 0.76281, 0.69841, 0.07397], -[11168, 0.70031, 0.85700, 0.33771], -[11169, 0.60559, 0.84134, 0.07973], -[11170, 0.87500, 0.69689, 0.50000], -[11171, 0.67774, 0.77514, 0.06277], -[11172, 0.73855, 0.70510, 0.04301], -[11173, 0.73505, 0.84229, 0.45846], -[11174, 0.86335, 0.70381, 0.39627], -[11175, 0.88909, 0.64062, 0.27481], -[11176, 0.21501, 1.00000, 0.04682], -[11177, 0.59017, 0.82734, 0.03206], -[11178, 0.67903, 0.78756, 0.08705], -[11179, 0.30311, 1.00000, 0.10000], -[11180, 0.41136, 1.00000, 0.21250], -[11181, 0.83522, 0.74184, 0.43646], -[11182, 0.69511, 0.83985, 0.24811], -[11183, 0.83423, 0.71646, 0.29319], -[11184, 0.72685, 0.72677, 0.05782], -[11185, 0.75805, 0.81694, 0.39972], -[11186, 0.55259, 0.87853, 0.08173], -[11187, 0.78120, 0.79732, 0.42092], -[11188, 0.90220, 0.65451, 0.40033], -[11189, 0.65554, 0.78590, 0.04731], -[11190, 0.50000, 0.97835, 0.28750], -[11191, 0.97835, 0.50000, 0.28750], -[11192, 1.00000, 0.05000, 0.00000], -[11193, 0.05000, 1.00000, 0.00000], -[11194, 1.00000, 0.50000, 0.45000], -[11195, 0.50000, 1.00000, 0.45000], -[11196, 0.94052, 0.60297, 0.43375], -[11197, 0.94542, 0.55591, 0.27707], -[11198, 0.97069, 0.50935, 0.27443], -[11199, 0.52376, 0.89727, 0.08383], -[11200, 0.51597, 0.90328, 0.08708], -[11201, 0.54487, 0.86298, 0.04051], -[11202, 1.00000, 0.34845, 0.13750], -[11203, 0.92849, 0.62474, 0.47787], -[11204, 0.56931, 0.93435, 0.26379], -[11205, 0.82238, 0.58620, 0.01731], -[11206, 0.65302, 0.88623, 0.29706], -[11207, 0.90148, 0.64720, 0.35332], -[11208, 0.87812, 0.66024, 0.28540], -[11209, 0.87876, 0.57980, 0.11954], -[11210, 0.64144, 0.90823, 0.37017], -[11211, 0.86543, 0.65366, 0.22260], -[11212, 0.93646, 0.58757, 0.32373], -[11213, 0.71651, 0.70000, 0.00000], -[11214, 0.76250, 0.81958, 0.48125], -[11215, 0.96283, 0.55629, 0.36938], -[11216, 0.80833, 0.74599, 0.29100], -[11217, 0.72073, 0.85226, 0.41177], -[11218, 0.58588, 0.91286, 0.22245], -[11219, 0.69262, 0.87252, 0.38779], -[11220, 0.84299, 0.62178, 0.10456], -[11221, 0.52339, 0.98981, 0.49373], -[11222, 0.99019, 0.52060, 0.45278], -[11223, 0.61181, 0.93536, 0.43259], -[11224, 0.63791, 0.78335, 0.01708], -[11225, 0.84729, 0.63262, 0.13163], -[11226, 0.78375, 0.71078, 0.13351], -[11227, 0.97631, 0.22500, 0.00000], -[11228, 0.72114, 0.74276, 0.07328], -[11229, 0.86243, 0.70334, 0.37600], -[11230, 0.85477, 0.69779, 0.30947], -[11231, 0.80000, 0.78349, 0.50000], -[11232, 0.77218, 0.72122, 0.12922], -[11233, 0.69140, 0.87827, 0.43284], -[11234, 0.94023, 0.60141, 0.40938], -[11235, 0.51313, 0.97341, 0.29237], -[11236, 0.74393, 0.83466, 0.43801], -[11237, 0.52570, 0.91042, 0.11432], -[11238, 0.59704, 0.92603, 0.29998], -[11239, 0.53358, 0.96220, 0.29139], -[11240, 0.89484, 0.64982, 0.32372], -[11241, 0.93875, 0.57119, 0.28361], -[11242, 0.58612, 0.84162, 0.04958], -[11243, 0.76694, 0.80823, 0.38447], -[11244, 0.82909, 0.60610, 0.05271], -[11245, 0.86445, 0.60590, 0.12520], -[11246, 0.85637, 0.63254, 0.15147], -[11247, 0.80311, 0.60000, 0.00000], -[11248, 0.59390, 0.86780, 0.11362], -[11249, 0.74563, 0.83592, 0.47793], -[11250, 0.16250, 1.00000, 0.02165], -[11251, 1.00000, 0.47835, 0.33750], -[11252, 0.47835, 1.00000, 0.33750], -[11253, 0.50000, 0.95670, 0.20000], -[11254, 0.66316, 0.88483, 0.31949], -[11255, 0.53359, 0.98277, 0.43125], -[11256, 0.88042, 0.63907, 0.23212], -[11257, 0.81546, 0.66539, 0.11579], -[11258, 0.66312, 0.82394, 0.13021], -[11259, 0.74916, 0.68955, 0.03232], -[11260, 0.80203, 0.70846, 0.16790], -[11261, 0.96426, 0.55075, 0.35042], -[11262, 0.32476, 1.00000, 0.11250], -[11263, 1.00000, 0.07500, 0.00000], -[11264, 0.07500, 1.00000, 0.00000], -[11265, 1.00000, 0.50000, 0.42500], -[11266, 0.50000, 1.00000, 0.42500], -[11267, 0.59477, 0.94362, 0.39279], -[11268, 0.50000, 0.93505, 0.13750], -[11269, 0.97330, 0.55511, 0.47840], -[11270, 0.65155, 0.76250, 0.00000], -[11271, 0.76637, 0.78984, 0.28836], -[11272, 0.69975, 0.79366, 0.13062], -[11273, 0.87614, 0.52012, 0.03324], -[11274, 0.59196, 0.85581, 0.08380], -[11275, 0.67560, 0.80875, 0.11834], -[11276, 0.79510, 0.78856, 0.45347], -[11277, 0.92689, 0.60951, 0.34005], -[11278, 0.74718, 0.78752, 0.22113], -[11279, 0.89156, 0.66834, 0.37873], -[11280, 0.90498, 0.63395, 0.31144], -[11281, 0.62596, 0.82844, 0.07771], -[11282, 0.77532, 0.78679, 0.30929], -[11283, 0.90046, 0.54251, 0.11092], -[11284, 0.61487, 0.92088, 0.32548], -[11285, 0.92473, 0.61827, 0.36119], -[11286, 0.73707, 0.80380, 0.24050], -[11287, 0.93941, 0.60140, 0.38792], -[11288, 0.65000, 0.91340, 0.50000], -[11289, 0.60569, 0.94201, 0.44942], -[11290, 0.83666, 0.72130, 0.30855], -[11291, 0.97976, 0.53713, 0.40768], -[11292, 0.69428, 0.83641, 0.22542], -[11293, 0.86585, 0.64521, 0.19830], -[11294, 0.97466, 0.52603, 0.32539], -[11295, 0.66531, 0.87185, 0.26672], -[11296, 0.98865, 0.52144, 0.41134], -[11297, 0.79645, 0.78648, 0.43423], -[11298, 0.95437, 0.51571, 0.21620], -[11299, 0.53438, 0.95458, 0.25391], -[11300, 0.85978, 0.66809, 0.23206], -[11301, 0.71408, 0.85641, 0.38137], -[11302, 0.38971, 1.00000, 0.17500], -[11303, 0.65410, 0.89925, 0.35496], -[11304, 0.79714, 0.78378, 0.41144], -[11305, 0.90427, 0.66026, 0.43708], -[11306, 0.81688, 0.65024, 0.09069], -[11307, 0.89651, 0.52861, 0.08228], -[11308, 0.71059, 0.73365, 0.03674], -[11309, 0.19065, 1.00000, 0.02940], -[11310, 0.81677, 0.62547, 0.05335], -[11311, 0.74707, 0.76507, 0.16180], -[11312, 0.98121, 0.54143, 0.45632], -[11313, 0.68911, 0.83181, 0.19817], -[11314, 0.91739, 0.53817, 0.14410], -[11315, 0.86213, 0.63709, 0.17024], -[11316, 0.96054, 0.53638, 0.28187], -[11317, 0.94714, 0.57080, 0.31225], -[11318, 0.94410, 0.54710, 0.24018], -[11319, 1.00000, 0.43505, 0.23750], -[11320, 0.89412, 0.67505, 0.44465], -[11321, 0.77595, 0.80851, 0.45042], -[11322, 0.86075, 0.60037, 0.10382], -[11323, 0.95163, 0.59200, 0.45259], -[11324, 0.56524, 0.89031, 0.11769], -[11325, 0.96645, 0.53349, 0.30074], -[11326, 0.75783, 0.82358, 0.42347], -[11327, 0.66181, 0.89171, 0.34022], -[11328, 0.56053, 0.92116, 0.19019], -[11329, 0.26203, 0.96964, 0.00000], -[11330, 0.55248, 0.93568, 0.22040], -[11331, 0.86945, 0.61451, 0.14590], -[11332, 0.81119, 0.77289, 0.44016], -[11333, 0.95466, 0.50000, 0.18750], -[11334, 0.95466, 0.31250, 0.00000], -[11335, 0.57293, 0.89550, 0.14097], -[11336, 0.81549, 0.74954, 0.32016], -[11337, 1.00000, 0.45670, 0.27500], -[11338, 0.45670, 1.00000, 0.27500], -[11339, 0.82901, 0.70776, 0.23345], -[11340, 0.32679, 0.95000, 0.00000], -[11341, 0.78426, 0.75661, 0.23203], -[11342, 0.88492, 0.56498, 0.10370], -[11343, 1.00000, 0.37010, 0.15000], -[11344, 0.85814, 0.53588, 0.01430], -[11345, 0.61194, 0.81352, 0.02755], -[11346, 0.88471, 0.51177, 0.03639], -[11347, 0.86548, 0.67586, 0.26817], -[11348, 0.82988, 0.69245, 0.19746], -[11349, 0.63380, 0.88662, 0.23175], -[11350, 0.68477, 0.88392, 0.40189], -[11351, 0.72689, 0.76663, 0.12081], -[11352, 0.56884, 0.96496, 0.42816], -[11353, 1.00000, 0.26184, 0.06250], -[11354, 1.00000, 0.10000, 0.00000], -[11355, 0.10000, 1.00000, 0.00000], -[11356, 1.00000, 0.50000, 0.40000], -[11357, 0.50000, 1.00000, 0.40000], -[11358, 0.80913, 0.60997, 0.01704], -[11359, 0.63645, 0.91340, 0.35620], -[11360, 0.96192, 0.57803, 0.47437], -[11361, 1.00000, 0.24019, 0.05000], -[11362, 0.86250, 0.71854, 0.50000], -[11363, 0.82413, 0.76036, 0.44615], -[11364, 0.71423, 0.83152, 0.25771], -[11365, 0.89997, 0.59431, 0.18836], -[11366, 0.83911, 0.65478, 0.14282], -[11367, 0.84101, 0.73739, 0.40229], -[11368, 0.34641, 1.00000, 0.12500], -[11369, 0.73016, 0.84325, 0.37159], -[11370, 1.00000, 0.41340, 0.20000], -[11371, 0.74022, 0.73031, 0.07616], -[11372, 1.00000, 0.28349, 0.07500], -[11373, 0.95861, 0.55172, 0.30581], -[11374, 0.92478, 0.63219, 0.42125], -[11375, 0.93301, 0.50000, 0.12500], -[11376, 0.57608, 0.96340, 0.46571], -[11377, 0.78771, 0.73473, 0.18225], -[11378, 0.62384, 0.84083, 0.09363], -[11379, 0.84209, 0.70082, 0.25280], -[11380, 0.71344, 0.80608, 0.17966], -[11381, 0.62650, 0.93093, 0.45220], -[11382, 0.56028, 0.86805, 0.05953], -[11383, 0.67687, 0.76698, 0.03628], -[11384, 0.23937, 0.97685, 0.00000], -[11385, 0.74997, 0.83096, 0.40693], -[11386, 0.76496, 0.82044, 0.44210], -[11387, 0.76890, 0.81817, 0.46461], -[11388, 0.61722, 0.82707, 0.05620], -[11389, 0.70503, 0.73005, 0.01838], -[11390, 0.91504, 0.57961, 0.20184], -[11391, 0.90110, 0.62358, 0.25233], -[11392, 0.91721, 0.64777, 0.46384], -[11393, 0.77652, 0.68311, 0.06118], -[11394, 0.57052, 0.96169, 0.39084], -[11395, 0.79114, 0.69498, 0.10837], -[11396, 0.74112, 0.83622, 0.38278], -[11397, 0.87198, 0.67887, 0.29734], -[11398, 0.64293, 0.89364, 0.27564], -[11399, 0.82659, 0.67373, 0.14619], -[11400, 0.64153, 0.82798, 0.09350], -[11401, 0.52974, 0.93290, 0.16608], -[11402, 0.97717, 0.53827, 0.36474], -[11403, 0.75461, 0.82060, 0.35828], -[11404, 0.61988, 0.80059, 0.01238], -[11405, 0.90200, 0.60311, 0.20737], -[11406, 0.76004, 0.69646, 0.05240], -[11407, 0.67166, 0.85062, 0.20269], -[11408, 0.43301, 1.00000, 0.22500], -[11409, 0.60582, 0.93613, 0.35940], -[11410, 0.93656, 0.55391, 0.21851], -[11411, 0.56213, 0.90985, 0.15447], -[11412, 0.69083, 0.88629, 0.47850], -[11413, 0.73825, 0.76756, 0.14074], -[11414, 1.00000, 0.30514, 0.08750], -[11415, 0.63607, 0.88111, 0.21283], -[11416, 0.95737, 0.57533, 0.37378], -[11417, 0.50000, 0.89312, 0.03542], -[11418, 0.50000, 0.97835, 0.26250], -[11419, 0.69527, 0.85746, 0.28776], -[11420, 0.73750, 0.84845, 0.50000], -[11421, 0.82301, 0.63665, 0.07437], -[11422, 0.94068, 0.59949, 0.35986], -[11423, 0.76957, 0.80466, 0.34437], -[11424, 0.64412, 0.86191, 0.17414], -[11425, 0.94150, 0.51393, 0.16324], -[11426, 1.00000, 0.47835, 0.31250], -[11427, 0.47835, 1.00000, 0.31250], -[11428, 0.73746, 0.75195, 0.10666], -[11429, 0.87232, 0.70494, 0.42155], -[11430, 0.84475, 0.58101, 0.03863], -[11431, 1.00000, 0.21962, 0.03542], -[11432, 0.62606, 0.90891, 0.28547], -[11433, 0.87130, 0.68789, 0.32180], -[11434, 0.84067, 0.66618, 0.16269], -[11435, 0.98773, 0.51594, 0.35000], -[11436, 0.52570, 0.86971, 0.01875], -[11437, 1.00000, 0.19689, 0.02500], -[11438, 0.65235, 0.91107, 0.40594], -[11439, 0.74180, 0.78900, 0.19727], -[11440, 0.88238, 0.68191, 0.35556], -[11441, 0.81276, 0.68393, 0.13096], -[11442, 0.78625, 0.66188, 0.04359], -[11443, 0.88737, 0.64430, 0.25089], -[11444, 0.80743, 0.65417, 0.07020], -[11445, 0.70554, 0.85439, 0.30807], -[11446, 0.57818, 0.83269, 0.01322], -[11447, 0.78565, 0.78665, 0.33101], -[11448, 0.77928, 0.76836, 0.24110], -[11449, 0.53076, 0.98634, 0.39900], -[11450, 0.55432, 0.96838, 0.35942], -[11451, 0.85376, 0.66833, 0.20113], -[11452, 0.58080, 0.85873, 0.06394], -[11453, 0.50000, 0.91340, 0.07500], -[11454, 0.73526, 0.80291, 0.21759], -[11455, 0.54026, 0.98570, 0.46041], -[11456, 0.56963, 0.88205, 0.09672], -[11457, 0.88669, 0.69188, 0.48270], -[11458, 0.86239, 0.72163, 0.47156], -[11459, 0.54981, 0.97415, 0.38118], -[11460, 0.93482, 0.61704, 0.39608], -[11461, 0.62910, 0.93227, 0.47635], -[11462, 0.72999, 0.84061, 0.33855], -[11463, 0.64800, 0.90420, 0.33234], -[11464, 1.00000, 0.12500, 0.00000], -[11465, 0.12500, 1.00000, 0.00000], -[11466, 0.50000, 0.87500, 0.00000], -[11467, 0.87500, 0.50000, 0.00000], -[11468, 1.00000, 0.50000, 0.37500], -[11469, 0.50000, 1.00000, 0.37500], -[11470, 0.97631, 0.50000, 0.25000], -[11471, 0.97631, 0.25000, 0.00000], -[11472, 0.67321, 0.75000, 0.00000], -[11473, 0.76131, 0.79478, 0.26651], -[11474, 0.78604, 0.79511, 0.37400], -[11475, 0.79356, 0.75920, 0.25535], -[11476, 0.52165, 0.86250, 0.00000], -[11477, 0.96423, 0.57272, 0.40891], -[11478, 0.77534, 0.70720, 0.09411], -[11479, 0.68892, 0.81938, 0.15346], -[11480, 0.74084, 0.82842, 0.32377], -[11481, 0.59095, 0.90374, 0.18333], -[11482, 0.77870, 0.65000, 0.01276], -[11483, 0.71967, 0.78612, 0.13891], -[11484, 0.64855, 0.88381, 0.24570], -[11485, 0.73354, 0.84677, 0.39342], -[11486, 0.47835, 0.88750, 0.00000], -[11487, 0.88750, 0.47835, 0.00000], -[11488, 0.83814, 0.62240, 0.07965], -[11489, 0.89405, 0.67895, 0.42015], -[11490, 0.75893, 0.71905, 0.08327], -[11491, 1.00000, 0.32679, 0.10000], -[11492, 0.80372, 0.63193, 0.02931], -[11493, 0.41136, 1.00000, 0.18750], -[11494, 0.36806, 1.00000, 0.13750], -[11495, 0.97499, 0.52070, 0.28749], -[11496, 0.67348, 0.83093, 0.14942], -[11497, 0.96526, 0.51969, 0.24470], -[11498, 0.61291, 0.86446, 0.12046], -[11499, 0.75001, 0.73582, 0.09618], -[11500, 0.54668, 0.90642, 0.11714], -[11501, 0.83868, 0.67842, 0.17843], -[11502, 0.78146, 0.63750, 0.00000], -[11503, 0.91186, 0.51895, 0.09215], -[11504, 0.51875, 0.96392, 0.23750], -[11505, 0.73800, 0.69945, 0.01691], -[11506, 0.89607, 0.57461, 0.13371], -[11507, 1.00000, 0.39175, 0.16250], -[11508, 0.51748, 0.94555, 0.17511], -[11509, 0.71520, 0.76622, 0.08910], -[11510, 0.73816, 0.68750, 0.00000], -[11511, 0.78994, 0.64826, 0.02744], -[11512, 0.58762, 0.86894, 0.09106], -[11513, 0.54330, 0.85000, 0.00000], -[11514, 0.81270, 0.77873, 0.47087], -[11515, 0.97886, 0.55309, 0.43847], -[11516, 0.68750, 0.89175, 0.50000], -[11517, 0.88912, 0.50000, 0.02315], -[11518, 0.64854, 0.84128, 0.12638], -[11519, 0.93613, 0.57920, 0.26293], -[11520, 0.69546, 0.78105, 0.08245], -[11521, 0.91738, 0.63125, 0.33260], -[11522, 0.63738, 0.91032, 0.31751], -[11523, 0.66462, 0.89976, 0.36960], -[11524, 0.62262, 0.93260, 0.39509], -[11525, 0.55528, 0.90971, 0.13602], -[11526, 0.78750, 0.80514, 0.50000], -[11527, 0.45670, 0.90000, 0.00000], -[11528, 0.90000, 0.45670, 0.00000], -[11529, 0.54207, 0.88106, 0.05438], -[11530, 0.95362, 0.57599, 0.33366], -[11531, 0.84641, 0.55000, 0.00000], -[11532, 0.63785, 0.81823, 0.06107], -[11533, 0.52401, 0.92574, 0.12924], -[11534, 0.81399, 0.73542, 0.24352], -[11535, 0.95788, 0.59290, 0.48766], -[11536, 0.86971, 0.67019, 0.24765], -[11537, 0.89971, 0.59003, 0.16578], -[11538, 0.69110, 0.82967, 0.17841], -[11539, 0.65386, 0.77607, 0.01055], -[11540, 0.90868, 0.55347, 0.12935], -[11541, 0.90470, 0.67071, 0.46711], -[11542, 0.80177, 0.78344, 0.38599], -[11543, 0.84548, 0.69469, 0.23118], -[11544, 0.83575, 0.74297, 0.36129], -[11545, 0.66222, 0.85452, 0.18212], -[11546, 0.70741, 0.82178, 0.19327], -[11547, 0.91053, 0.62504, 0.27610], -[11548, 0.67324, 0.90247, 0.45299], -[11549, 0.77907, 0.71554, 0.11136], -[11550, 0.25981, 1.00000, 0.05000], -[11551, 0.78321, 0.75216, 0.19853], -[11552, 0.75757, 0.75188, 0.13831], -[11553, 0.54059, 0.98870, 0.48255], -[11554, 0.75587, 0.74310, 0.11716], -[11555, 0.84356, 0.57776, 0.02580], -[11556, 0.86439, 0.54783, 0.02778], -[11557, 0.85000, 0.74019, 0.50000], -[11558, 0.84852, 0.58995, 0.05009], -[11559, 0.91715, 0.64513, 0.38562], -[11560, 0.76877, 0.76709, 0.19826], -[11561, 0.82823, 0.75487, 0.37873], -[11562, 0.70406, 0.76624, 0.06672], -[11563, 0.56495, 0.83750, 0.00000], -[11564, 0.28146, 1.00000, 0.06250], -[11565, 0.82940, 0.73671, 0.29995], -[11566, 0.60530, 0.94678, 0.41095], -[11567, 0.87892, 0.69850, 0.39819], -[11568, 0.50000, 0.95670, 0.17500], -[11569, 1.00000, 0.45670, 0.25000], -[11570, 0.78689, 0.77980, 0.29072], -[11571, 0.78854, 0.79943, 0.39853], -[11572, 0.82744, 0.76526, 0.46956], -[11573, 0.85724, 0.73224, 0.48653], -[11574, 1.00000, 0.34845, 0.11250], -[11575, 0.93807, 0.62306, 0.44107], -[11576, 0.76392, 0.80611, 0.30438], -[11577, 0.52285, 0.91166, 0.09114], -[11578, 0.62301, 0.88379, 0.17995], -[11579, 0.56388, 0.97534, 0.45036], -[11580, 0.64460, 0.92454, 0.46177], -[11581, 0.63184, 0.80624, 0.02825], -[11582, 0.68969, 0.87083, 0.30559], -[11583, 0.60008, 0.93803, 0.32139], -[11584, 0.43505, 0.91250, 0.00000], -[11585, 0.91250, 0.43505, 0.00000], -[11586, 1.00000, 0.43505, 0.21250], -[11587, 0.91136, 0.50000, 0.06250], -[11588, 0.69182, 0.79880, 0.10585], -[11589, 0.97500, 0.56699, 0.50000], -[11590, 0.79934, 0.74544, 0.22153], -[11591, 0.81335, 0.76466, 0.33877], -[11592, 0.66349, 0.87597, 0.24543], -[11593, 0.95458, 0.58295, 0.35403], -[11594, 0.84914, 0.68500, 0.21346], -[11595, 0.54037, 0.94658, 0.20941], -[11596, 0.30311, 1.00000, 0.07500], -[11597, 1.00000, 0.15000, 0.00000], -[11598, 0.15000, 1.00000, 0.00000], -[11599, 1.00000, 0.50000, 0.35000], -[11600, 0.50000, 1.00000, 0.35000], -[11601, 0.62900, 0.87226, 0.15935], -[11602, 0.51748, 0.90511, 0.06908], -[11603, 0.56898, 0.95595, 0.31241], -[11604, 0.86087, 0.72093, 0.39068], -[11605, 0.68352, 0.85655, 0.23172], -[11606, 0.30429, 0.96458, 0.00000], -[11607, 0.80577, 0.72910, 0.19627], -[11608, 0.55344, 0.89807, 0.09958], -[11609, 0.84128, 0.74311, 0.38474], -[11610, 0.88869, 0.68468, 0.37859], -[11611, 0.60455, 0.91320, 0.22817], -[11612, 0.81793, 0.69452, 0.15067], -[11613, 0.91926, 0.61094, 0.26521], -[11614, 0.62133, 0.89793, 0.21516], -[11615, 0.81919, 0.71440, 0.19658], -[11616, 0.79774, 0.79776, 0.47306], -[11617, 0.59351, 0.92896, 0.25852], -[11618, 0.56250, 0.97835, 0.50000], -[11619, 0.69928, 0.74988, 0.02844], -[11620, 0.79735, 0.67415, 0.07171], -[11621, 0.86121, 0.62824, 0.12944], -[11622, 0.92572, 0.59858, 0.25784], -[11623, 0.72152, 0.81827, 0.21057], -[11624, 1.00000, 0.52221, 0.46458], -[11625, 1.00000, 0.47835, 0.28750], -[11626, 0.21250, 1.00000, 0.02165], -[11627, 0.47835, 1.00000, 0.28750], -[11628, 0.67518, 0.84055, 0.16594], -[11629, 0.57455, 0.91496, 0.17309], -[11630, 0.88945, 0.69356, 0.45438], -[11631, 0.66261, 0.91198, 0.44101], -[11632, 0.91929, 0.53469, 0.12148], -[11633, 0.38971, 1.00000, 0.15000], -[11634, 0.50000, 0.93505, 0.11250], -[11635, 0.70990, 0.87615, 0.44596], -[11636, 0.72836, 0.80761, 0.19705], -[11637, 0.73569, 0.83401, 0.30559], -[11638, 0.92864, 0.61001, 0.29967], -[11639, 0.57258, 0.85877, 0.04250], -[11640, 0.65635, 0.83066, 0.10776], -[11641, 0.60198, 0.84985, 0.06401], -[11642, 0.58660, 0.82500, 0.00000], -[11643, 0.65525, 0.81020, 0.06527], -[11644, 0.52369, 1.00000, 0.47500], -[11645, 0.86119, 0.68603, 0.24969], -[11646, 0.95000, 0.61029, 0.50000], -[11647, 0.92826, 0.56180, 0.18738], -[11648, 0.63896, 0.89721, 0.25138], -[11649, 0.60000, 0.95670, 0.50000], -[11650, 0.95466, 0.50000, 0.16250], -[11651, 0.95466, 0.33750, 0.00000], -[11652, 0.89188, 0.66494, 0.30576], -[11653, 0.82300, 0.61648, 0.03316], -[11654, 0.63150, 0.86299, 0.13694], -[11655, 0.82476, 0.58750, 0.00000], -[11656, 0.67332, 0.90359, 0.42527], -[11657, 0.55616, 0.95977, 0.28801], -[11658, 0.72588, 0.72360, 0.02554], -[11659, 0.32476, 1.00000, 0.08750], -[11660, 0.52500, 1.00000, 0.50000], -[11661, 0.45466, 1.00000, 0.23750], -[11662, 1.00000, 0.52500, 0.50000], -[11663, 0.89795, 0.56526, 0.11282], -[11664, 0.69130, 0.88315, 0.36618], -[11665, 0.54097, 0.98207, 0.36331], -[11666, 0.82282, 0.70181, 0.17404], -[11667, 1.00000, 0.52165, 0.43750], -[11668, 0.90510, 0.61878, 0.22808], -[11669, 0.87919, 0.70907, 0.48240], -[11670, 0.50000, 0.97835, 0.23750], -[11671, 0.57820, 0.95871, 0.34945], -[11672, 0.56520, 0.94340, 0.24156], -[11673, 0.66879, 0.80768, 0.07963], -[11674, 0.91753, 0.62591, 0.29334], -[11675, 0.92580, 0.51875, 0.11250], -[11676, 0.86183, 0.57444, 0.04876], -[11677, 0.41340, 0.92500, 0.00000], -[11678, 0.92500, 0.41340, 0.00000], -[11679, 1.00000, 0.41340, 0.17500], -[11680, 0.95035, 0.54383, 0.22122], -[11681, 0.82998, 0.74999, 0.34081], -[11682, 0.95759, 0.59075, 0.39634], -[11683, 0.68260, 0.90017, 0.47791], -[11684, 0.69486, 0.73750, 0.00000], -[11685, 0.52369, 1.00000, 0.45000], -[11686, 0.71960, 0.85899, 0.35485], -[11687, 0.63670, 0.88098, 0.19139], -[11688, 0.82215, 0.74131, 0.27340], -[11689, 0.89529, 0.62647, 0.21202], -[11690, 0.64684, 0.80638, 0.04358], -[11691, 0.56192, 0.98005, 0.47275], -[11692, 0.55537, 0.92672, 0.16851], -[11693, 0.78566, 0.81238, 0.48387], -[11694, 0.66024, 0.88451, 0.25667], -[11695, 0.43301, 1.00000, 0.20000], -[11696, 0.65247, 0.87254, 0.19922], -[11697, 0.59119, 0.92742, 0.23938], -[11698, 0.72243, 0.86797, 0.45243], -[11699, 0.91902, 0.59945, 0.22863], -[11700, 1.00000, 0.37010, 0.12500], -[11701, 0.88765, 0.59597, 0.13320], -[11702, 0.53556, 0.93035, 0.14600], -[11703, 0.65110, 0.79467, 0.02855], -[11704, 0.63267, 0.90583, 0.26136], -[11705, 0.55660, 0.95386, 0.25877], -[11706, 0.52962, 0.95469, 0.20682], -[11707, 0.81800, 0.72824, 0.21991], -[11708, 0.93633, 0.57256, 0.22908], -[11709, 0.85523, 0.72158, 0.33915], -[11710, 0.73748, 0.78560, 0.15804], -[11711, 0.23728, 1.00000, 0.02915], -[11712, 0.83724, 0.72460, 0.27199], -[11713, 0.81568, 0.77776, 0.41069], -[11714, 0.93750, 0.63194, 0.50000], -[11715, 0.57542, 0.93321, 0.22376], -[11716, 0.83479, 0.70504, 0.20930], -[11717, 0.61929, 0.84162, 0.06770], -[11718, 0.86083, 0.59048, 0.06516], -[11719, 0.97631, 0.50000, 0.22500], -[11720, 0.97631, 0.27500, 0.00000], -[11721, 0.84915, 0.74236, 0.41821], -[11722, 0.62645, 0.93739, 0.41194], -[11723, 0.52580, 0.95290, 0.19274], -[11724, 0.88493, 0.63366, 0.19283], -[11725, 0.80195, 0.68485, 0.09150], -[11726, 0.64968, 0.92385, 0.43918], -[11727, 0.96845, 0.53319, 0.26104], -[11728, 0.67095, 0.90440, 0.39424], -[11729, 0.56432, 0.96584, 0.33260], -[11730, 0.68426, 0.89296, 0.38277], -[11731, 0.55581, 0.98193, 0.41981], -[11732, 0.90580, 0.66479, 0.36895], -[11733, 0.51346, 0.98789, 0.29996], -[11734, 1.00000, 0.52165, 0.41250], -[11735, 0.95536, 0.59304, 0.37572], -[11736, 0.52369, 1.00000, 0.42500], -[11737, 0.60118, 0.91227, 0.20626], -[11738, 0.34641, 1.00000, 0.10000], -[11739, 0.84455, 0.75149, 0.45509], -[11740, 0.60825, 0.81250, 0.00000], -[11741, 0.58687, 0.88588, 0.11139], -[11742, 0.58459, 0.96719, 0.44473], -[11743, 0.52930, 0.98681, 0.33763], -[11744, 0.60955, 0.91985, 0.24956], -[11745, 0.55024, 0.95336, 0.23779], -[11746, 0.93301, 0.50000, 0.10000], -[11747, 0.93531, 0.59574, 0.27461], -[11748, 0.73474, 0.79783, 0.17728], -[11749, 0.51097, 0.90936, 0.06125], -[11750, 0.64133, 0.91031, 0.29848], -[11751, 1.00000, 0.17500, 0.00000], -[11752, 0.17500, 1.00000, 0.00000], -[11753, 1.00000, 0.50000, 0.32500], -[11754, 0.50000, 1.00000, 0.32500], -[11755, 0.77294, 0.75187, 0.15662], -[11756, 0.90021, 0.66898, 0.34914], -[11757, 0.81634, 0.77316, 0.37153], -[11758, 0.63750, 0.93505, 0.50000], -[11759, 0.72004, 0.85640, 0.32984], -[11760, 0.56934, 0.95259, 0.27781], -[11761, 0.28349, 0.97500, 0.00000], -[11762, 0.58126, 0.92474, 0.20338], -[11763, 0.96801, 0.58467, 0.45369], -[11764, 0.94515, 0.58929, 0.29879], -[11765, 0.92296, 0.64861, 0.40765], -[11766, 0.74398, 0.84094, 0.35653], -[11767, 0.86002, 0.69813, 0.26689], -[11768, 0.73018, 0.86170, 0.42438], -[11769, 0.88000, 0.70960, 0.44094], -[11770, 0.67264, 0.88496, 0.28590], -[11771, 0.52824, 0.98155, 0.30253], -[11772, 0.92396, 0.61664, 0.28185], -[11773, 0.75773, 0.83360, 0.38789], -[11774, 0.75032, 0.82458, 0.30321], -[11775, 0.69387, 0.86103, 0.25743], -[11776, 0.61013, 0.92591, 0.27166], -[11777, 0.96816, 0.56545, 0.34299], -[11778, 0.62001, 0.92596, 0.30001], -[11779, 0.83750, 0.76184, 0.50000], -[11780, 0.57442, 0.87803, 0.07462], -[11781, 0.89014, 0.55445, 0.07326], -[11782, 0.77893, 0.75367, 0.17270], -[11783, 0.78115, 0.81489, 0.41261], -[11784, 0.98233, 0.55080, 0.38328], -[11785, 0.96954, 0.57374, 0.38659], -[11786, 0.92272, 0.56322, 0.16316], -[11787, 0.63178, 0.93738, 0.43428], -[11788, 0.91179, 0.66577, 0.41307], -[11789, 0.82221, 0.77126, 0.39365], -[11790, 0.74055, 0.82883, 0.28355], -[11791, 0.54825, 0.94046, 0.18815], -[11792, 0.39175, 0.93750, 0.00000], -[11793, 0.93750, 0.39175, 0.00000], -[11794, 0.66171, 0.89991, 0.31364], -[11795, 0.95649, 0.51282, 0.17655], -[11796, 0.86874, 0.72456, 0.44610], -[11797, 0.57140, 0.96978, 0.37471], -[11798, 0.72500, 0.87010, 0.50000], -[11799, 0.92500, 0.65359, 0.50000], -[11800, 0.80862, 0.75981, 0.27267], -[11801, 0.54275, 0.96739, 0.27099], -[11802, 0.55999, 0.94020, 0.20783], -[11803, 0.75981, 0.67500, 0.00000], -[11804, 0.68422, 0.76210, 0.01614], -[11805, 0.71200, 0.84896, 0.26457], -[11806, 0.41136, 1.00000, 0.16250], -[11807, 0.83422, 0.66865, 0.12547], -[11808, 0.68032, 0.87112, 0.25147], -[11809, 0.60392, 0.95653, 0.43839], -[11810, 0.88442, 0.64670, 0.21172], -[11811, 0.51742, 0.88971, 0.02641], -[11812, 0.55219, 0.98379, 0.39557], -[11813, 0.77931, 0.66972, 0.02263], -[11814, 0.61937, 0.94811, 0.46566], -[11815, 0.81386, 0.74866, 0.25330], -[11816, 0.64996, 0.89666, 0.25986], -[11817, 1.00000, 0.45670, 0.22500], -[11818, 0.77500, 0.82679, 0.50000], -[11819, 0.93029, 0.62030, 0.31559], -[11820, 0.73367, 0.82861, 0.25593], -[11821, 0.71475, 0.75544, 0.04950], -[11822, 1.00000, 0.30514, 0.06250], -[11823, 0.80687, 0.76874, 0.29375], -[11824, 0.94791, 0.53313, 0.18080], -[11825, 0.82050, 0.78080, 0.45651], -[11826, 1.00000, 0.52165, 0.38750], -[11827, 0.52165, 1.00000, 0.38750], -[11828, 1.00000, 0.23948, 0.02306], -[11829, 0.94525, 0.54707, 0.19659], -[11830, 0.67586, 0.88750, 0.29895], -[11831, 1.00000, 0.39175, 0.13750], -[11832, 0.86148, 0.72487, 0.36807], -[11833, 0.84161, 0.58867, 0.02026], -[11834, 0.77043, 0.78657, 0.23026], -[11835, 0.91779, 0.58302, 0.17930], -[11836, 1.00000, 0.47835, 0.26250], -[11837, 0.88573, 0.51767, 0.01751], -[11838, 0.73938, 0.75195, 0.08377], -[11839, 0.88919, 0.62278, 0.17306], -[11840, 0.58929, 0.94640, 0.29384], -[11841, 0.84572, 0.75491, 0.48002], -[11842, 0.98540, 0.52523, 0.30337], -[11843, 0.76228, 0.82032, 0.32234], -[11844, 0.90324, 0.68529, 0.48793], -[11845, 0.80311, 0.62500, 0.00000], -[11846, 0.36806, 1.00000, 0.11250], -[11847, 0.76033, 0.80143, 0.24455], -[11848, 0.70227, 0.88487, 0.40249], -[11849, 0.90049, 0.53005, 0.05971], -[11850, 0.63410, 0.92582, 0.33703], -[11851, 0.91912, 0.66377, 0.47911], -[11852, 0.69989, 0.89100, 0.45431], -[11853, 0.72471, 0.85097, 0.30866], -[11854, 0.76621, 0.68447, 0.01978], -[11855, 0.74108, 0.85809, 0.47409], -[11856, 0.95009, 0.59805, 0.33896], -[11857, 0.88799, 0.66536, 0.26531], -[11858, 0.96964, 0.58831, 0.50000], -[11859, 0.51106, 0.96622, 0.19731], -[11860, 0.80755, 0.70368, 0.12698], -[11861, 0.71048, 0.88068, 0.42186], -[11862, 0.52600, 0.98046, 0.27970], -[11863, 0.65937, 0.82637, 0.08907], -[11864, 0.54291, 0.95576, 0.22017], -[11865, 1.00000, 0.28499, 0.04682], -[11866, 0.94629, 0.61980, 0.41578], -[11867, 0.62990, 0.80000, 0.00000], -[11868, 0.80665, 0.65183, 0.04040], -[11869, 0.50000, 0.91340, 0.05000], -[11870, 0.86696, 0.70984, 0.32288], -[11871, 0.66484, 0.91909, 0.48817], -[11872, 0.91176, 0.64085, 0.28807], -[11873, 1.00000, 0.43505, 0.18750], -[11874, 0.69779, 0.87801, 0.32881], -[11875, 0.70585, 0.87549, 0.35015], -[11876, 0.86074, 0.60856, 0.08050], -[11877, 1.00000, 0.32679, 0.07500], -[11878, 0.69785, 0.77033, 0.04499], -[11879, 0.59302, 0.89310, 0.12834], -[11880, 0.96535, 0.59581, 0.47303], -[11881, 0.65586, 0.91878, 0.38459], -[11882, 0.59317, 0.96416, 0.42092], -[11883, 0.50000, 0.95670, 0.15000], -[11884, 0.76254, 0.71690, 0.06126], -[11885, 0.61363, 0.89308, 0.16268], -[11886, 0.75925, 0.83349, 0.37051], -[11887, 0.78977, 0.69553, 0.07523], -[11888, 0.88051, 0.66184, 0.22682], -[11889, 0.67515, 0.88125, 0.26439], -[11890, 0.95671, 0.55913, 0.25489], -[11891, 0.89785, 0.67081, 0.32133], -[11892, 0.93299, 0.64417, 0.44802], -[11893, 0.61476, 0.85737, 0.08154], -[11894, 0.59664, 0.95332, 0.34724], -[11895, 0.77632, 0.81644, 0.36221], -[11896, 0.88223, 0.56618, 0.06474], -[11897, 0.71892, 0.78877, 0.11355], -[11898, 0.52648, 0.97588, 0.25721], -[11899, 0.77789, 0.78859, 0.25188], -[11900, 0.71097, 0.84547, 0.23867], -[11901, 0.60664, 0.84161, 0.03928], -[11902, 0.71973, 0.87241, 0.40254], -[11903, 0.91250, 0.67524, 0.50000], -[11904, 0.87707, 0.64228, 0.17305], -[11905, 0.52062, 0.90045, 0.04517], -[11906, 0.54243, 0.92341, 0.12320], -[11907, 0.58965, 0.96324, 0.38416], -[11908, 0.87657, 0.70553, 0.34896], -[11909, 0.67949, 0.79716, 0.06204], -[11910, 0.71651, 0.72500, 0.00000], -[11911, 0.66325, 0.91830, 0.42303], -[11912, 0.82583, 0.67907, 0.11769], -[11913, 0.71783, 0.85345, 0.28633], -[11914, 0.95072, 0.62059, 0.48142], -[11915, 0.45466, 1.00000, 0.21250], -[11916, 0.47631, 1.00000, 0.25000], -[11917, 0.59078, 0.94253, 0.27186], -[11918, 0.86224, 0.70775, 0.28763], -[11919, 0.37010, 0.95000, 0.00000], -[11920, 0.81825, 0.78402, 0.42742], -[11921, 0.55419, 0.97348, 0.31346], -[11922, 0.69023, 0.89944, 0.43527], -[11923, 0.61257, 0.88456, 0.13682], -[11924, 0.69662, 0.80017, 0.09495], -[11925, 0.58111, 0.97555, 0.48453], -[11926, 0.85800, 0.74150, 0.43938], -[11927, 0.88364, 0.54646, 0.04144], -[11928, 0.67853, 0.87185, 0.23694], -[11929, 0.62867, 0.93497, 0.35738], -[11930, 0.50000, 0.97835, 0.21250], -[11931, 0.73407, 0.82298, 0.22852], -[11932, 0.63568, 0.86187, 0.12193], -[11933, 0.53882, 0.88333, 0.03176], -[11934, 0.63662, 0.93219, 0.37498], -[11935, 0.67171, 0.78017, 0.02036], -[11936, 0.67500, 0.91340, 0.50000], -[11937, 1.00000, 0.20000, 0.00000], -[11938, 0.20000, 1.00000, 0.00000], -[11939, 1.00000, 0.50000, 0.30000], -[11940, 0.50000, 1.00000, 0.30000], -[11941, 0.97709, 0.56288, 0.36402], -[11942, 0.90275, 0.55590, 0.09240], -[11943, 0.72364, 0.80639, 0.15909], -[11944, 0.90957, 0.65177, 0.30492], -[11945, 0.68292, 0.78571, 0.04561], -[11946, 0.92563, 0.65458, 0.42958], -[11947, 0.96485, 0.59383, 0.41791], -[11948, 0.65041, 0.85871, 0.13954], -[11949, 0.71551, 0.80120, 0.13055], -[11950, 0.79372, 0.80991, 0.43289], -[11951, 0.64071, 0.85044, 0.10414], -[11952, 0.61771, 0.93914, 0.33578], -[11953, 1.00000, 0.26272, 0.02915], -[11954, 0.84556, 0.69368, 0.19250], -[11955, 0.92473, 0.64568, 0.36301], -[11956, 0.74979, 0.76490, 0.12107], -[11957, 0.58828, 0.84991, 0.02827], -[11958, 0.68121, 0.81771, 0.10216], -[11959, 0.81535, 0.79125, 0.48898], -[11960, 1.00000, 0.52165, 0.36250], -[11961, 0.52165, 1.00000, 0.36250], -[11962, 0.80230, 0.72045, 0.14176], -[11963, 0.86772, 0.72951, 0.42238], -[11964, 0.75432, 0.84615, 0.42106], -[11965, 0.60576, 0.87250, 0.09628], -[11966, 0.88465, 0.71228, 0.46458], -[11967, 0.95264, 0.36566, 0.00000], -[11968, 0.52149, 0.94686, 0.14948], -[11969, 0.91537, 0.57291, 0.14603], -[11970, 0.61926, 0.94475, 0.37590], -[11971, 1.00000, 0.34845, 0.08750], -[11972, 0.84220, 0.65372, 0.10634], -[11973, 0.67550, 0.86709, 0.21108], -[11974, 0.70863, 0.82284, 0.16471], -[11975, 0.81535, 0.72372, 0.17874], -[11976, 0.97962, 0.54585, 0.31491], -[11977, 0.53985, 0.90310, 0.07005], -[11978, 0.75451, 0.81653, 0.26362], -[11979, 0.83338, 0.72447, 0.23067], -[11980, 0.98074, 0.51052, 0.23619], -[11981, 0.60213, 0.95580, 0.37363], -[11982, 0.78247, 0.77386, 0.21540], -[11983, 0.89209, 0.68494, 0.33502], -[11984, 0.59875, 0.96555, 0.46274], -[11985, 0.86922, 0.53542, 0.00000], -[11986, 0.75400, 0.78576, 0.17399], -[11987, 0.93022, 0.63445, 0.34374], -[11988, 0.58437, 0.90870, 0.14611], -[11989, 0.87470, 0.59455, 0.08300], -[11990, 0.98365, 0.56178, 0.40341], -[11991, 0.38971, 1.00000, 0.12500], -[11992, 0.76587, 0.78778, 0.20779], -[11993, 0.97957, 0.57269, 0.42879], -[11994, 0.96424, 0.59888, 0.43464], -[11995, 0.94550, 0.51973, 0.14138], -[11996, 0.58575, 0.95914, 0.32777], -[11997, 0.62542, 0.86179, 0.10139], -[11998, 0.84889, 0.73835, 0.33573], -[11999, 0.95466, 0.50000, 0.13750], -[12000, 0.65818, 0.88347, 0.21859], -[12001, 0.75723, 0.84739, 0.46176], -[12002, 0.70893, 0.81437, 0.14337], -[12003, 0.43301, 1.00000, 0.17500], -[12004, 0.93146, 0.59878, 0.24112], -[12005, 0.97631, 0.50000, 0.20000], -[12006, 0.97631, 0.30000, 0.00000], -[12007, 0.85145, 0.60961, 0.05660], -[12008, 0.85834, 0.56844, 0.01694], -[12009, 0.55125, 0.90131, 0.07928], -[12010, 0.77777, 0.69000, 0.03931], -[12011, 0.68486, 0.85108, 0.18390], -[12012, 0.91667, 0.53787, 0.09533], -[12013, 1.00000, 0.41340, 0.15000], -[12014, 0.81278, 0.78094, 0.34800], -[12015, 0.79613, 0.77841, 0.26767], -[12016, 0.79827, 0.79589, 0.34782], -[12017, 0.90099, 0.65965, 0.28336], -[12018, 0.83862, 0.68871, 0.15877], -[12019, 0.71274, 0.87733, 0.37198], -[12020, 0.76660, 0.83826, 0.43879], -[12021, 0.88299, 0.60323, 0.11192], -[12022, 0.98273, 0.57192, 0.46359], -[12023, 0.89043, 0.57396, 0.08536], -[12024, 0.57570, 0.97724, 0.41152], -[12025, 0.56980, 0.85846, 0.01766], -[12026, 0.68936, 0.82755, 0.13360], -[12027, 0.87672, 0.69119, 0.28105], -[12028, 0.30311, 1.00000, 0.05000], -[12029, 0.84344, 0.60413, 0.03304], -[12030, 0.28038, 1.00000, 0.03542], -[12031, 0.50000, 0.93505, 0.08750], -[12032, 0.82500, 0.78349, 0.50000], -[12033, 0.65155, 0.78750, 0.00000], -[12034, 0.94338, 0.53606, 0.15739], -[12035, 0.64506, 0.93200, 0.39995], -[12036, 0.85954, 0.66911, 0.17091], -[12037, 0.86934, 0.62147, 0.10905], -[12038, 0.96907, 0.56822, 0.31854], -[12039, 0.81789, 0.67157, 0.08165], -[12040, 0.76950, 0.76950, 0.16716], -[12041, 0.80486, 0.75983, 0.23537], -[12042, 0.26052, 1.00000, 0.02306], -[12043, 0.66690, 0.85437, 0.15266], -[12044, 0.91694, 0.52244, 0.07381], -[12045, 0.56224, 0.91124, 0.11405], -[12046, 0.59787, 0.90931, 0.16647], -[12047, 0.77434, 0.73004, 0.09628], -[12048, 0.74710, 0.72135, 0.03402], -[12049, 0.90000, 0.69689, 0.50000], -[12050, 0.94625, 0.56294, 0.21126], -[12051, 0.86147, 0.71878, 0.30787], -[12052, 1.00000, 0.54330, 0.47500], -[12053, 0.73076, 0.84342, 0.27519], -[12054, 0.78320, 0.79447, 0.27344], -[12055, 0.85357, 0.72449, 0.29344], -[12056, 0.81354, 0.79471, 0.44719], -[12057, 0.78485, 0.80532, 0.32198], -[12058, 0.73402, 0.73913, 0.04037], -[12059, 0.95712, 0.61475, 0.45081], -[12060, 0.95850, 0.56923, 0.26825], -[12061, 0.80433, 0.80138, 0.41448], -[12062, 0.71714, 0.78752, 0.09746], -[12063, 0.88778, 0.58752, 0.09587], -[12064, 0.54196, 0.91730, 0.09794], -[12065, 0.84006, 0.64347, 0.07919], -[12066, 0.79812, 0.78938, 0.30832], -[12067, 0.32476, 1.00000, 0.06250], -[12068, 0.67023, 0.90445, 0.32772], -[12069, 0.53239, 0.96856, 0.22547], -[12070, 1.00000, 0.37010, 0.10000], -[12071, 0.66839, 0.84602, 0.13321], -[12072, 0.84641, 0.57500, 0.00000], -[12073, 0.78981, 0.81223, 0.38318], -[12074, 0.96678, 0.54345, 0.24086], -[12075, 0.84377, 0.75842, 0.39871], -[12076, 0.93800, 0.63903, 0.40387], -[12077, 0.94655, 0.63247, 0.46105], -[12078, 0.81367, 0.74173, 0.20795], -[12079, 0.85857, 0.64940, 0.12756], -[12080, 0.68498, 0.89210, 0.31947], -[12081, 1.00000, 0.54330, 0.45000], -[12082, 0.66879, 0.92172, 0.47101], -[12083, 0.97982, 0.54265, 0.29217], -[12084, 1.00000, 0.47835, 0.23750], -[12085, 0.73673, 0.78515, 0.12781], -[12086, 0.34845, 0.96250, 0.00000], -[12087, 0.69551, 0.81716, 0.11739], -[12088, 0.76918, 0.81123, 0.28048], -[12089, 0.83304, 0.76442, 0.35840], -[12090, 0.69125, 0.87984, 0.28452], -[12091, 0.77600, 0.74062, 0.11569], -[12092, 0.72682, 0.76466, 0.06935], -[12093, 0.93057, 0.59196, 0.21340], -[12094, 1.00000, 0.52165, 0.33750], -[12095, 0.52165, 1.00000, 0.33750], -[12096, 1.00000, 0.45670, 0.20000], -[12097, 0.87601, 0.66771, 0.20785], -[12098, 0.98239, 0.57518, 0.44711], -[12099, 0.64815, 0.93385, 0.41857], -[12100, 0.60827, 0.88322, 0.11430], -[12101, 0.72868, 0.87608, 0.48053], -[12102, 0.78713, 0.80908, 0.34283], -[12103, 0.83329, 0.60750, 0.01470], -[12104, 0.93961, 0.64097, 0.42728], -[12105, 0.67030, 0.90925, 0.34828], -[12106, 0.55450, 0.87209, 0.01932], -[12107, 0.97309, 0.52532, 0.22375], -[12108, 0.75671, 0.70874, 0.02643], -[12109, 0.58037, 0.90625, 0.12436], -[12110, 0.92186, 0.61939, 0.24344], -[12111, 0.74003, 0.74774, 0.06121], -[12112, 0.92193, 0.66896, 0.45692], -[12113, 0.63560, 0.82536, 0.03721], -[12114, 0.86035, 0.74762, 0.48176], -[12115, 0.54611, 1.00000, 0.46458], -[12116, 0.79848, 0.76230, 0.21556], -[12117, 0.78146, 0.66250, 0.00000], -[12118, 0.69839, 0.90083, 0.48025], -[12119, 0.57927, 0.95145, 0.25717], -[12120, 0.98486, 0.55226, 0.34191], -[12121, 0.56001, 0.88024, 0.04007], -[12122, 0.80765, 0.79377, 0.36634], -[12123, 0.81375, 0.69400, 0.10449], -[12124, 0.59378, 0.96849, 0.40145], -[12125, 0.89656, 0.52883, 0.03441], -[12126, 0.77568, 0.82725, 0.38055], -[12127, 0.61350, 0.95558, 0.39597], -[12128, 0.85233, 0.71920, 0.26200], -[12129, 0.87697, 0.70244, 0.30513], -[12130, 0.60428, 0.91588, 0.18917], -[12131, 0.89340, 0.65986, 0.24110], -[12132, 0.81550, 0.79660, 0.46808], -[12133, 0.92729, 0.63568, 0.30849], -[12134, 0.34641, 1.00000, 0.07500], -[12135, 0.41136, 1.00000, 0.13750], -[12136, 1.00000, 0.22500, 0.00000], -[12137, 0.22500, 1.00000, 0.00000], -[12138, 1.00000, 0.50000, 0.27500], -[12139, 0.50000, 1.00000, 0.27500], -[12140, 0.64656, 0.83717, 0.07369], -[12141, 0.79491, 0.81700, 0.46416], -[12142, 0.75472, 0.83959, 0.33817], -[12143, 1.00000, 0.54330, 0.42500], -[12144, 0.83877, 0.62607, 0.04681], -[12145, 0.94618, 0.61861, 0.34840], -[12146, 0.74048, 0.85002, 0.32644], -[12147, 0.78452, 0.80224, 0.29501], -[12148, 0.93301, 0.50000, 0.07500], -[12149, 0.88994, 0.67979, 0.28307], -[12150, 0.76250, 0.84845, 0.50000], -[12151, 0.54534, 1.00000, 0.43750], -[12152, 0.75208, 0.85580, 0.44177], -[12153, 0.89188, 0.61853, 0.14871], -[12154, 0.63863, 0.88564, 0.16932], -[12155, 0.88252, 0.61983, 0.12778], -[12156, 0.91708, 0.65909, 0.33829], -[12157, 0.87768, 0.63582, 0.14354], -[12158, 0.69857, 0.78755, 0.06016], -[12159, 0.85116, 0.70998, 0.22951], -[12160, 0.91169, 0.50000, 0.03036], -[12161, 0.63014, 0.91545, 0.24146], -[12162, 0.94301, 0.64221, 0.48103], -[12163, 0.96399, 0.57621, 0.29762], -[12164, 0.92961, 0.54885, 0.13007], -[12165, 0.97703, 0.54271, 0.26938], -[12166, 0.58750, 0.97835, 0.50000], -[12167, 0.91842, 0.63348, 0.26008], -[12168, 0.92156, 0.61309, 0.22192], -[12169, 0.47631, 1.00000, 0.22500], -[12170, 1.00000, 0.55000, 0.50000], -[12171, 0.55000, 1.00000, 0.50000], -[12172, 0.73816, 0.71250, 0.00000], -[12173, 0.62155, 0.82616, 0.01654], -[12174, 0.84815, 0.73948, 0.30888], -[12175, 0.71250, 0.89175, 0.50000], -[12176, 0.56194, 0.89094, 0.06030], -[12177, 0.92141, 0.60025, 0.19404], -[12178, 0.94499, 0.61603, 0.32562], -[12179, 0.71691, 0.88792, 0.47605], -[12180, 0.77054, 0.83719, 0.40871], -[12181, 0.86247, 0.65809, 0.14487], -[12182, 0.96021, 0.58927, 0.31613], -[12183, 1.00000, 0.43505, 0.16250], -[12184, 0.66399, 0.82531, 0.07436], -[12185, 0.88108, 0.71982, 0.40641], -[12186, 0.90465, 0.68834, 0.39477], -[12187, 0.68694, 0.89841, 0.34427], -[12188, 0.89981, 0.58800, 0.11543], -[12189, 0.63321, 0.94979, 0.48391], -[12190, 0.55274, 0.98700, 0.34607], -[12191, 0.91567, 0.51448, 0.05231], -[12192, 1.00000, 0.39175, 0.11250], -[12193, 0.52402, 0.93305, 0.10195], -[12194, 0.73442, 0.86544, 0.37568], -[12195, 0.92738, 0.64383, 0.32892], -[12196, 0.82991, 0.65856, 0.07412], -[12197, 0.67321, 0.77500, 0.00000], -[12198, 0.59492, 0.86257, 0.04624], -[12199, 0.78095, 0.70511, 0.05631], -[12200, 0.97044, 0.56087, 0.28180], -[12201, 0.82764, 0.69111, 0.12407], -[12202, 0.88750, 0.71854, 0.50000], -[12203, 0.90030, 0.64663, 0.22554], -[12204, 0.64182, 0.94379, 0.46348], -[12205, 0.95243, 0.57864, 0.25068], -[12206, 0.54908, 0.96982, 0.25064], -[12207, 0.90543, 0.62470, 0.19309], -[12208, 0.72113, 0.74588, 0.02261], -[12209, 0.83476, 0.77563, 0.42329], -[12210, 0.88381, 0.54049, 0.01927], -[12211, 0.45466, 1.00000, 0.18750], -[12212, 0.86792, 0.68948, 0.22468], -[12213, 0.66812, 0.89627, 0.26592], -[12214, 0.84933, 0.67532, 0.14349], -[12215, 0.71320, 0.84279, 0.20722], -[12216, 0.76790, 0.83206, 0.34913], -[12217, 0.94102, 0.63660, 0.38179], -[12218, 0.82887, 0.67661, 0.10003], -[12219, 0.50000, 0.97835, 0.18750], -[12220, 0.61597, 0.90744, 0.18044], -[12221, 0.54534, 1.00000, 0.41250], -[12222, 0.79888, 0.74063, 0.15601], -[12223, 0.74427, 0.85264, 0.34459], -[12224, 0.88558, 0.71805, 0.42730], -[12225, 1.00000, 0.54330, 0.40000], -[12226, 0.82664, 0.75926, 0.28691], -[12227, 0.81531, 0.78005, 0.32099], -[12228, 0.95134, 0.61929, 0.37077], -[12229, 0.82069, 0.62908, 0.01410], -[12230, 0.82476, 0.61250, 0.00000], -[12231, 0.90654, 0.65346, 0.26214], -[12232, 0.54691, 0.98076, 0.28919], -[12233, 0.59751, 0.93210, 0.21782], -[12234, 0.85347, 0.64118, 0.09247], -[12235, 0.36806, 1.00000, 0.08750], -[12236, 0.95727, 0.56324, 0.23154], -[12237, 0.68900, 0.90740, 0.41270], -[12238, 0.86999, 0.67102, 0.18594], -[12239, 0.77085, 0.76028, 0.13449], -[12240, 0.96413, 0.53627, 0.20219], -[12241, 0.71980, 0.87152, 0.33219], -[12242, 0.98125, 0.57217, 0.37500], -[12243, 0.50000, 0.95670, 0.12500], -[12244, 0.62500, 0.95670, 0.50000], -[12245, 0.73942, 0.77801, 0.10762], -[12246, 0.78029, 0.71866, 0.07483], -[12247, 0.57559, 0.90357, 0.10205], -[12248, 0.94406, 0.55317, 0.17003], -[12249, 0.82490, 0.63934, 0.03421], -[12250, 0.52239, 0.94348, 0.12162], -[12251, 0.87915, 0.72993, 0.47615], -[12252, 0.65180, 0.93874, 0.48519], -[12253, 0.65837, 0.87033, 0.16024], -[12254, 0.57441, 0.96585, 0.29118], -[12255, 0.91615, 0.68006, 0.43178], -[12256, 0.61732, 0.95950, 0.43012], -[12257, 0.57460, 0.97719, 0.35321], -[12258, 0.69504, 0.84378, 0.16598], -[12259, 0.53507, 0.96620, 0.20537], -[12260, 0.83536, 0.74070, 0.25464], -[12261, 0.89669, 0.70402, 0.41535], -[12262, 0.93582, 0.55375, 0.14713], -[12263, 0.90382, 0.69946, 0.47129], -[12264, 0.91348, 0.60466, 0.17295], -[12265, 1.00000, 0.52165, 0.31250], -[12266, 0.52165, 1.00000, 0.31250], -[12267, 0.94321, 0.60739, 0.27910], -[12268, 0.62895, 0.93734, 0.31784], -[12269, 0.53791, 0.91744, 0.08008], -[12270, 0.32679, 0.97500, 0.00000], -[12271, 0.81626, 0.72268, 0.15522], -[12272, 0.60859, 0.96555, 0.43035], -[12273, 0.61176, 0.94739, 0.31098], -[12274, 0.91087, 0.54459, 0.07414], -[12275, 0.60458, 0.94678, 0.28599], -[12276, 0.93903, 0.65247, 0.48241], -[12277, 0.57941, 0.87842, 0.05221], -[12278, 0.71474, 0.86928, 0.29662], -[12279, 0.92177, 0.66873, 0.39457], -[12280, 0.77049, 0.70711, 0.03688], -[12281, 0.98382, 0.52883, 0.25387], -[12282, 0.95983, 0.61169, 0.38709], -[12283, 0.95640, 0.58710, 0.27888], -[12284, 0.71596, 0.78416, 0.07477], -[12285, 0.66385, 0.93133, 0.48347], -[12286, 0.81250, 0.80514, 0.50000], -[12287, 0.73073, 0.83315, 0.21650], -[12288, 0.70633, 0.84399, 0.18790], -[12289, 0.60415, 0.90426, 0.14501], -[12290, 0.91190, 0.68912, 0.45244], -[12291, 0.51390, 0.96557, 0.16486], -[12292, 0.83859, 0.77652, 0.44953], -[12293, 0.97631, 0.50000, 0.17500], -[12294, 0.97631, 0.32500, 0.00000], -[12295, 0.70813, 0.86941, 0.27297], -[12296, 0.66327, 0.92208, 0.36306], -[12297, 0.75283, 0.73358, 0.04831], -[12298, 0.63543, 0.85447, 0.08159], -[12299, 0.58132, 0.97959, 0.39233], -[12300, 0.74172, 0.86580, 0.40259], -[12301, 0.62125, 0.91128, 0.19525], -[12302, 0.86313, 0.70690, 0.24590], -[12303, 0.65191, 0.88503, 0.18218], -[12304, 0.56670, 0.95444, 0.22175], -[12305, 0.71463, 0.88636, 0.38503], -[12306, 0.64557, 0.91844, 0.27801], -[12307, 0.75895, 0.78235, 0.15135], -[12308, 0.53947, 0.95469, 0.17251], -[12309, 0.52165, 0.88750, 0.00000], -[12310, 0.87064, 0.74168, 0.45855], -[12311, 0.66617, 0.79899, 0.02285], -[12312, 0.79759, 0.68938, 0.05453], -[12313, 0.93609, 0.58261, 0.19316], -[12314, 0.43301, 1.00000, 0.15000], -[12315, 0.90000, 0.50000, 0.00000], -[12316, 0.50000, 0.90000, 0.00000], -[12317, 0.56088, 0.98886, 0.36746], -[12318, 0.54534, 1.00000, 0.38750], -[12319, 0.52040, 0.92789, 0.07775], -[12320, 0.94926, 0.61008, 0.30764], -[12321, 0.58125, 0.98538, 0.46154], -[12322, 0.63157, 0.84193, 0.04972], -[12323, 0.66620, 0.90624, 0.28675], -[12324, 0.97620, 0.58273, 0.36563], -[12325, 0.90395, 0.69979, 0.43740], -[12326, 0.86376, 0.74137, 0.37728], -[12327, 0.85138, 0.76250, 0.43285], -[12328, 0.54330, 0.87500, 0.00000], -[12329, 1.00000, 0.54330, 0.37500], -[12330, 0.79203, 0.74004, 0.13121], -[12331, 0.58463, 0.95864, 0.27585], -[12332, 0.68097, 0.92034, 0.48215], -[12333, 0.59000, 0.96198, 0.30603], -[12334, 0.65768, 0.82507, 0.05516], -[12335, 0.58818, 0.89155, 0.08708], -[12336, 0.61628, 0.96500, 0.48091], -[12337, 0.47835, 0.91250, 0.00000], -[12338, 1.00000, 0.47835, 0.21250], -[12339, 1.00000, 0.28750, 0.02165], -[12340, 0.91250, 0.47835, 0.00000], -[12341, 0.85362, 0.66679, 0.12821], -[12342, 1.00000, 0.41340, 0.12500], -[12343, 0.95466, 0.50000, 0.11250], -[12344, 0.85004, 0.75669, 0.37177], -[12345, 0.54705, 0.95801, 0.19249], -[12346, 0.90220, 0.69317, 0.36842], -[12347, 0.50000, 0.91345, 0.02315], -[12348, 0.86945, 0.73902, 0.40154], -[12349, 0.38971, 1.00000, 0.10000], -[12350, 0.83558, 0.69498, 0.13848], -[12351, 0.60332, 0.94098, 0.25001], -[12352, 0.56985, 0.90101, 0.08119], -[12353, 0.98779, 0.57971, 0.48660], -[12354, 0.80248, 0.71381, 0.10172], -[12355, 1.00000, 0.32964, 0.04881], -[12356, 0.91386, 0.68558, 0.41589], -[12357, 0.69258, 0.77862, 0.02423], -[12358, 0.57943, 0.92775, 0.15957], -[12359, 0.73268, 0.82070, 0.18048], -[12360, 1.00000, 0.25000, 0.00000], -[12361, 0.25000, 1.00000, 0.00000], -[12362, 1.00000, 0.50000, 0.25000], -[12363, 0.50000, 1.00000, 0.25000], -[12364, 0.86497, 0.59655, 0.04341], -[12365, 0.64838, 0.91227, 0.25524], -[12366, 0.69955, 0.85795, 0.20483], -[12367, 0.88336, 0.67995, 0.23557], -[12368, 0.52622, 0.98353, 0.23843], -[12369, 0.91026, 0.59259, 0.13536], -[12370, 0.59547, 0.97852, 0.47420], -[12371, 1.00000, 0.34845, 0.06250], -[12372, 0.64961, 0.89527, 0.20085], -[12373, 0.58421, 0.94946, 0.23495], -[12374, 0.51318, 0.91371, 0.03648], -[12375, 0.56495, 0.86250, 0.00000], -[12376, 0.88698, 0.65646, 0.19110], -[12377, 0.86654, 0.68657, 0.19856], -[12378, 0.68854, 0.90583, 0.36382], -[12379, 0.74254, 0.82228, 0.20733], -[12380, 0.60204, 0.84636, 0.01582], -[12381, 0.66250, 0.93505, 0.50000], -[12382, 0.57588, 0.94010, 0.18720], -[12383, 0.65605, 0.91958, 0.30696], -[12384, 0.62898, 0.93242, 0.27988], -[12385, 0.96274, 0.60509, 0.35679], -[12386, 0.87500, 0.74019, 0.50000], -[12387, 0.75016, 0.80912, 0.19001], -[12388, 0.67155, 0.80800, 0.04205], -[12389, 0.80764, 0.74479, 0.17318], -[12390, 0.76706, 0.79060, 0.18297], -[12391, 0.88836, 0.70294, 0.32478], -[12392, 0.59051, 0.92886, 0.17964], -[12393, 0.82625, 0.74852, 0.23324], -[12394, 0.70184, 0.80204, 0.07768], -[12395, 0.45670, 0.92500, 0.00000], -[12396, 0.92500, 0.45670, 0.00000], -[12397, 1.00000, 0.45670, 0.17500], -[12398, 0.92851, 0.65988, 0.37096], -[12399, 0.69486, 0.76250, 0.00000], -[12400, 0.88912, 0.52315, 0.00000], -[12401, 0.75990, 0.84642, 0.35724], -[12402, 0.94586, 0.51814, 0.11115], -[12403, 0.53507, 0.94411, 0.12988], -[12404, 0.56560, 0.96336, 0.24177], -[12405, 0.76532, 0.80679, 0.22065], -[12406, 0.81238, 0.65009, 0.01824], -[12407, 0.93568, 0.52301, 0.09299], -[12408, 0.80898, 0.75328, 0.19522], -[12409, 0.88022, 0.69364, 0.25705], -[12410, 0.93864, 0.62603, 0.29498], -[12411, 0.94695, 0.58435, 0.22283], -[12412, 0.93402, 0.65634, 0.39120], -[12413, 0.83306, 0.78774, 0.47489], -[12414, 0.76430, 0.74330, 0.07746], -[12415, 0.61799, 0.95522, 0.35550], -[12416, 0.97978, 0.58790, 0.40150], -[12417, 0.85109, 0.75376, 0.34902], -[12418, 0.69646, 0.86990, 0.22834], -[12419, 0.84348, 0.71490, 0.19487], -[12420, 0.50000, 0.93505, 0.06250], -[12421, 0.89375, 0.70693, 0.36885], -[12422, 0.96192, 0.52251, 0.15719], -[12423, 0.92039, 0.57248, 0.12449], -[12424, 0.53371, 0.88947, 0.01023], -[12425, 0.66295, 0.85218, 0.11238], -[12426, 0.89861, 0.71299, 0.48909], -[12427, 0.83034, 0.73318, 0.20162], -[12428, 0.73478, 0.77790, 0.08634], -[12429, 0.68759, 0.84845, 0.14855], -[12430, 0.52801, 0.91469, 0.05186], -[12431, 0.54534, 1.00000, 0.36250], -[12432, 0.79293, 0.78571, 0.23477], -[12433, 0.86272, 0.58863, 0.02492], -[12434, 0.97172, 0.34965, 0.00000], -[12435, 0.80248, 0.66927, 0.02607], -[12436, 0.58056, 0.98704, 0.42768], -[12437, 0.62288, 0.84024, 0.02818], -[12438, 0.67086, 0.92567, 0.40153], -[12439, 0.58660, 0.85000, 0.00000], -[12440, 0.98279, 0.59158, 0.47174], -[12441, 0.77503, 0.84597, 0.48252], -[12442, 0.67601, 0.81824, 0.06394], -[12443, 0.95587, 0.62623, 0.39592], -[12444, 0.81280, 0.77160, 0.25342], -[12445, 0.98299, 0.51235, 0.20325], -[12446, 0.47631, 1.00000, 0.20000], -[12447, 0.82225, 0.79183, 0.38243], -[12448, 0.64477, 0.90673, 0.21863], -[12449, 1.00000, 0.30935, 0.02940], -[12450, 0.69373, 0.91310, 0.45339], -[12451, 0.52165, 1.00000, 0.28750], -[12452, 1.00000, 0.52165, 0.28750], -[12453, 0.75981, 0.70000, 0.00000], -[12454, 0.67256, 0.89697, 0.25405], -[12455, 0.77609, 0.81048, 0.25859], -[12456, 0.80311, 0.65000, 0.00000], -[12457, 0.88075, 0.56246, 0.02522], -[12458, 0.30311, 1.00000, 0.02500], -[12459, 0.65151, 0.93454, 0.35972], -[12460, 1.00000, 0.37010, 0.07500], -[12461, 1.00000, 0.54330, 0.35000], -[12462, 0.88236, 0.60896, 0.08969], -[12463, 0.75656, 0.85541, 0.38315], -[12464, 0.68696, 0.83705, 0.11880], -[12465, 0.64256, 0.93023, 0.30076], -[12466, 0.83265, 0.65125, 0.05225], -[12467, 0.96038, 0.55461, 0.20332], -[12468, 0.84384, 0.74634, 0.27886], -[12469, 0.68402, 0.91965, 0.43376], -[12470, 0.43505, 0.93750, 0.00000], -[12471, 0.93750, 0.43505, 0.00000], -[12472, 0.88047, 0.72357, 0.36025], -[12473, 0.61913, 0.92381, 0.21434], -[12474, 0.86922, 0.73013, 0.32749], -[12475, 0.92429, 0.55647, 0.10692], -[12476, 0.84962, 0.77211, 0.47788], -[12477, 0.94886, 0.60158, 0.26273], -[12478, 0.59887, 0.88046, 0.07005], -[12479, 0.85771, 0.70558, 0.20795], -[12480, 0.65531, 0.93022, 0.34466], -[12481, 0.76102, 0.76038, 0.09799], -[12482, 0.90537, 0.69107, 0.35267], -[12483, 0.73789, 0.87794, 0.43868], -[12484, 0.83830, 0.77549, 0.37782], -[12485, 0.80277, 0.81475, 0.39587], -[12486, 0.61151, 0.93467, 0.23225], -[12487, 1.00000, 0.56425, 0.46964], -[12488, 0.32476, 1.00000, 0.03750], -[12489, 0.41136, 1.00000, 0.11250], -[12490, 0.93058, 0.63730, 0.28256], -[12491, 0.85496, 0.66285, 0.11376], -[12492, 0.75000, 0.87010, 0.50000], -[12493, 0.88177, 0.58755, 0.05621], -[12494, 0.63326, 0.88599, 0.13432], -[12495, 0.91217, 0.51511, 0.02835], -[12496, 0.73461, 0.80350, 0.13305], -[12497, 0.54906, 0.90011, 0.04364], -[12498, 0.86806, 0.56250, 0.00000], -[12499, 0.95394, 0.63780, 0.44359], -[12500, 0.87930, 0.72140, 0.33742], -[12501, 0.65335, 0.90826, 0.23863], -[12502, 0.65754, 0.85001, 0.09346], -[12503, 0.66163, 0.93909, 0.47483], -[12504, 0.70562, 0.89939, 0.38323], -[12505, 0.73085, 0.85134, 0.25190], -[12506, 0.92196, 0.59294, 0.15511], -[12507, 0.77314, 0.82711, 0.30328], -[12508, 0.45466, 1.00000, 0.16250], -[12509, 1.00000, 0.43505, 0.13750], -[12510, 0.71807, 0.77793, 0.05277], -[12511, 0.57661, 0.97715, 0.31683], -[12512, 0.97569, 0.60708, 0.48140], -[12513, 0.59334, 0.98316, 0.45239], -[12514, 0.74130, 0.87750, 0.46139], -[12515, 0.92209, 0.68562, 0.47272], -[12516, 0.50000, 0.97835, 0.16250], -[12517, 0.81219, 0.69167, 0.07211], -[12518, 0.72483, 0.89081, 0.45251], -[12519, 0.81638, 0.67623, 0.05563], -[12520, 0.93752, 0.57862, 0.17213], -[12521, 0.58074, 0.87369, 0.03017], -[12522, 0.63945, 0.92476, 0.26066], -[12523, 0.60825, 0.83750, 0.00000], -[12524, 0.78761, 0.83392, 0.42372], -[12525, 0.71610, 0.85657, 0.22563], -[12526, 0.67502, 0.83935, 0.09791], -[12527, 0.62133, 0.86151, 0.05993], -[12528, 0.90912, 0.61164, 0.15151], -[12529, 0.56699, 1.00000, 0.47500], -[12530, 0.74535, 0.85253, 0.30048], -[12531, 0.89809, 0.69367, 0.31444], -[12532, 0.55123, 0.90992, 0.06359], -[12533, 0.77431, 0.83245, 0.32714], -[12534, 0.89774, 0.71078, 0.39355], -[12535, 0.68379, 0.89813, 0.28024], -[12536, 0.34641, 1.00000, 0.05000], -[12537, 0.65071, 0.93143, 0.32219], -[12538, 0.83948, 0.76365, 0.31339], -[12539, 0.68546, 0.92275, 0.46258], -[12540, 0.70553, 0.83682, 0.14677], -[12541, 0.58214, 0.97881, 0.33906], -[12542, 0.52803, 0.97146, 0.18322], -[12543, 0.84674, 0.75912, 0.32765], -[12544, 0.69526, 0.88496, 0.26245], -[12545, 0.83491, 0.70998, 0.15095], -[12546, 0.83598, 0.78392, 0.40190], -[12547, 0.93301, 0.50000, 0.05000], -[12548, 1.00000, 0.56495, 0.43750], -[12549, 0.80437, 0.79416, 0.28674], -[12550, 0.86971, 0.62636, 0.08233], -[12551, 0.79891, 0.81596, 0.36170], -[12552, 0.58354, 0.94721, 0.20765], -[12553, 0.94633, 0.63869, 0.35955], -[12554, 0.75612, 0.83986, 0.28507], -[12555, 0.82996, 0.76084, 0.26425], -[12556, 0.91936, 0.68037, 0.37661], -[12557, 0.61224, 0.97046, 0.41783], -[12558, 0.41340, 0.95000, 0.00000], -[12559, 0.95000, 0.41340, 0.00000], -[12560, 0.55960, 0.92833, 0.11467], -[12561, 0.97474, 0.59825, 0.37586], -[12562, 0.80344, 0.81911, 0.41616], -[12563, 0.80000, 0.82679, 0.50000], -[12564, 1.00000, 0.39175, 0.08750], -[12565, 0.98297, 0.56369, 0.30084], -[12566, 0.56085, 0.98116, 0.28433], -[12567, 0.54534, 1.00000, 0.33750], -[12568, 0.97734, 0.60542, 0.45424], -[12569, 0.80864, 0.81662, 0.44472], -[12570, 0.63393, 0.95853, 0.44296], -[12571, 0.78891, 0.68839, 0.02286], -[12572, 0.82639, 0.79649, 0.41856], -[12573, 0.56070, 0.91918, 0.09418], -[12574, 0.56699, 1.00000, 0.45000], -[12575, 0.57042, 0.97128, 0.26450], -[12576, 0.69801, 0.89290, 0.30060], -[12577, 0.70000, 0.91340, 0.50000], -[12578, 0.82230, 0.75369, 0.21703], -[12579, 0.86250, 0.76184, 0.50000], -[12580, 0.75451, 0.86815, 0.46154], -[12581, 0.82191, 0.71750, 0.13358], -[12582, 0.63827, 0.95409, 0.41629], -[12583, 0.67079, 0.89645, 0.23328], -[12584, 0.91363, 0.68022, 0.33474], -[12585, 0.79059, 0.76334, 0.15788], -[12586, 0.81812, 0.80313, 0.39684], -[12587, 0.71514, 0.86614, 0.24789], -[12588, 0.74731, 0.84327, 0.26414], -[12589, 0.57759, 0.92533, 0.13205], -[12590, 0.50000, 0.95670, 0.10000], -[12591, 0.69038, 0.82031, 0.08070], -[12592, 0.90433, 0.71077, 0.45132], -[12593, 0.96087, 0.63334, 0.46743], -[12594, 0.92142, 0.67498, 0.35552], -[12595, 0.65800, 0.86534, 0.12082], -[12596, 1.00000, 0.27500, 0.00000], -[12597, 0.27500, 1.00000, 0.00000], -[12598, 1.00000, 0.50000, 0.22500], -[12599, 0.50000, 1.00000, 0.22500], -[12600, 0.89799, 0.66536, 0.22329], -[12601, 0.97631, 0.50000, 0.15000], -[12602, 1.00000, 0.54330, 0.32500], -[12603, 0.65264, 0.94654, 0.43717], -[12604, 0.71651, 0.75000, 0.00000], -[12605, 0.96278, 0.54768, 0.18519], -[12606, 0.63961, 0.90311, 0.18172], -[12607, 0.75987, 0.84483, 0.31313], -[12608, 0.83379, 0.79194, 0.43905], -[12609, 0.95150, 0.59382, 0.23900], -[12610, 0.71264, 0.77051, 0.02612], -[12611, 0.64805, 0.84404, 0.05985], -[12612, 0.70322, 0.81473, 0.09032], -[12613, 0.73479, 0.88275, 0.41644], -[12614, 0.89956, 0.64275, 0.17765], -[12615, 0.71854, 0.89509, 0.40591], -[12616, 0.75193, 0.86891, 0.42292], -[12617, 0.61534, 0.97193, 0.44455], -[12618, 0.84641, 0.60000, 0.00000], -[12619, 0.56406, 0.93722, 0.13956], -[12620, 0.80741, 0.82116, 0.48405], -[12621, 1.00000, 0.47835, 0.18750], -[12622, 0.78539, 0.78561, 0.19588], -[12623, 0.81989, 0.80833, 0.46965], -[12624, 0.96645, 0.62285, 0.43127], -[12625, 0.88176, 0.65730, 0.15774], -[12626, 0.80737, 0.72791, 0.11917], -[12627, 0.91340, 0.57700, 0.10054], -[12628, 1.00000, 0.56495, 0.41250], -[12629, 0.92421, 0.61934, 0.20152], -[12630, 0.36806, 1.00000, 0.06250], -[12631, 0.59037, 0.86028, 0.01187], -[12632, 0.56699, 1.00000, 0.42500], -[12633, 0.76448, 0.78207, 0.13796], -[12634, 0.59425, 0.90594, 0.10841], -[12635, 0.88087, 0.73992, 0.43806], -[12636, 0.74244, 0.73812, 0.01903], -[12637, 0.84129, 0.62691, 0.02400], -[12638, 0.62990, 0.82500, 0.00000], -[12639, 0.60310, 0.89496, 0.09651], -[12640, 0.84794, 0.70670, 0.16957], -[12641, 0.65942, 0.81942, 0.02948], -[12642, 0.89329, 0.56716, 0.04387], -[12643, 0.72889, 0.83592, 0.18746], -[12644, 0.74611, 0.81035, 0.16175], -[12645, 0.86931, 0.75242, 0.42264], -[12646, 0.86202, 0.68867, 0.16756], -[12647, 0.68167, 0.92181, 0.38386], -[12648, 0.72690, 0.86410, 0.27007], -[12649, 0.90381, 0.66830, 0.24618], -[12650, 0.63963, 0.95206, 0.38846], -[12651, 0.51210, 0.94642, 0.08758], -[12652, 0.61210, 0.96252, 0.33578], -[12653, 0.43301, 1.00000, 0.12500], -[12654, 0.87237, 0.61223, 0.06151], -[12655, 0.92654, 0.65925, 0.31270], -[12656, 0.79325, 0.83559, 0.47317], -[12657, 0.54048, 0.94000, 0.10955], -[12658, 0.80759, 0.70994, 0.08522], -[12659, 0.79158, 0.83187, 0.40120], -[12660, 0.68181, 0.92537, 0.41472], -[12661, 0.84816, 0.72581, 0.21314], -[12662, 0.91678, 0.63688, 0.21290], -[12663, 1.00000, 0.52165, 0.26250], -[12664, 0.97566, 0.59225, 0.33905], -[12665, 0.91555, 0.64986, 0.23914], -[12666, 0.81018, 0.81150, 0.38293], -[12667, 0.90241, 0.60976, 0.12229], -[12668, 0.53427, 0.90530, 0.02686], -[12669, 0.90732, 0.55319, 0.05315], -[12670, 0.93847, 0.57164, 0.15149], -[12671, 0.78156, 0.80555, 0.23684], -[12672, 0.91495, 0.67642, 0.31360], -[12673, 0.87055, 0.74089, 0.34945], -[12674, 0.79408, 0.73518, 0.10191], -[12675, 0.79471, 0.83400, 0.45030], -[12676, 0.54931, 0.97378, 0.21782], -[12677, 0.91391, 0.69886, 0.42267], -[12678, 0.68196, 0.90895, 0.30417], -[12679, 0.95000, 0.65359, 0.50000], -[12680, 0.98125, 0.60104, 0.42500], -[12681, 0.82957, 0.78899, 0.36144], -[12682, 0.97565, 0.51716, 0.16741], -[12683, 0.71158, 0.90564, 0.44102], -[12684, 0.95282, 0.52791, 0.12121], -[12685, 0.95131, 0.57218, 0.18745], -[12686, 0.67067, 0.92264, 0.32937], -[12687, 0.90905, 0.56747, 0.07359], -[12688, 0.91008, 0.67790, 0.29393], -[12689, 0.85045, 0.75151, 0.29449], -[12690, 0.76711, 0.82061, 0.23832], -[12691, 0.97795, 0.61168, 0.50000], -[12692, 1.00000, 0.57500, 0.50000], -[12693, 0.57500, 1.00000, 0.50000], -[12694, 0.95273, 0.58118, 0.20811], -[12695, 0.51745, 0.98588, 0.19811], -[12696, 0.95016, 0.65311, 0.46120], -[12697, 1.00000, 0.41340, 0.10000], -[12698, 0.92437, 0.63438, 0.22784], -[12699, 0.85142, 0.66149, 0.08953], -[12700, 0.73820, 0.86733, 0.31618], -[12701, 1.00000, 0.45670, 0.15000], -[12702, 0.74799, 0.83968, 0.24200], -[12703, 0.68281, 0.87606, 0.18786], -[12704, 0.82132, 0.77867, 0.27586], -[12705, 0.75103, 0.87565, 0.48097], -[12706, 0.76621, 0.83047, 0.26670], -[12707, 0.93706, 0.66645, 0.40494], -[12708, 0.77322, 0.70545, 0.01444], -[12709, 0.61052, 0.90233, 0.11982], -[12710, 0.56699, 1.00000, 0.40000], -[12711, 0.88522, 0.73124, 0.38514], -[12712, 0.95466, 0.50000, 0.08750], -[12713, 0.72866, 0.86942, 0.28858], -[12714, 0.81074, 0.80186, 0.32289], -[12715, 0.97642, 0.54776, 0.22019], -[12716, 1.00000, 0.56495, 0.38750], -[12717, 0.70864, 0.89945, 0.35548], -[12718, 0.78539, 0.79663, 0.21603], -[12719, 0.85349, 0.77183, 0.41055], -[12720, 0.79053, 0.82238, 0.32383], -[12721, 0.86295, 0.63213, 0.06639], -[12722, 0.61250, 0.97835, 0.50000], -[12723, 0.69190, 0.80762, 0.05120], -[12724, 0.38971, 1.00000, 0.07500], -[12725, 0.47631, 1.00000, 0.17500], -[12726, 0.59793, 0.92356, 0.15066], -[12727, 0.54534, 1.00000, 0.31250], -[12728, 0.76602, 0.77382, 0.11658], -[12729, 0.74458, 0.86918, 0.34917], -[12730, 0.62773, 0.94740, 0.29723], -[12731, 0.71324, 0.90705, 0.46388], -[12732, 0.59504, 0.96702, 0.29111], -[12733, 0.65917, 0.94063, 0.38361], -[12734, 0.71398, 0.88832, 0.31561], -[12735, 0.60310, 0.95887, 0.27699], -[12736, 0.87490, 0.71533, 0.26373], -[12737, 0.59985, 0.93802, 0.19451], -[12738, 0.67019, 0.93758, 0.42998], -[12739, 0.63946, 0.95226, 0.36796], -[12740, 0.96577, 0.59905, 0.29611], -[12741, 0.78186, 0.74472, 0.09102], -[12742, 0.84807, 0.67724, 0.10578], -[12743, 0.78146, 0.68750, 0.00000], -[12744, 1.00000, 0.35115, 0.04159], -[12745, 0.87358, 0.72431, 0.28608], -[12746, 0.93960, 0.67081, 0.47148], -[12747, 0.52420, 0.96175, 0.13402], -[12748, 0.51194, 0.93057, 0.04649], -[12749, 0.58357, 0.89688, 0.06522], -[12750, 0.62675, 0.90181, 0.14219], -[12751, 0.71815, 0.81985, 0.11761], -[12752, 0.68194, 0.89052, 0.22417], -[12753, 0.90824, 0.64585, 0.19635], -[12754, 0.68390, 0.86803, 0.16371], -[12755, 0.72619, 0.82762, 0.15071], -[12756, 0.82532, 0.71054, 0.11477], -[12757, 0.59525, 0.98594, 0.41007], -[12758, 0.89658, 0.57949, 0.05852], -[12759, 0.56934, 0.95842, 0.19679], -[12760, 0.65155, 0.81250, 0.00000], -[12761, 0.86206, 0.76159, 0.39245], -[12762, 0.97100, 0.61983, 0.41196], -[12763, 0.62710, 0.87659, 0.08391], -[12764, 0.96384, 0.58937, 0.25818], -[12765, 0.93750, 0.67524, 0.50000], -[12766, 0.95876, 0.63906, 0.41474], -[12767, 0.65233, 0.86674, 0.10232], -[12768, 0.39312, 0.96458, 0.00000], -[12769, 0.94695, 0.65903, 0.43718], -[12770, 0.90893, 0.67446, 0.26771], -[12771, 0.67386, 0.88814, 0.19634], -[12772, 0.83536, 0.72581, 0.16758], -[12773, 0.92236, 0.53610, 0.05617], -[12774, 1.00000, 0.54330, 0.30000], -[12775, 0.96502, 0.39238, 0.00000], -[12776, 0.88136, 0.58385, 0.03355], -[12777, 0.74968, 0.76681, 0.06961], -[12778, 0.98908, 0.59746, 0.49222], -[12779, 0.89719, 0.68521, 0.25333], -[12780, 0.82396, 0.79248, 0.33098], -[12781, 0.66853, 0.84485, 0.08189], -[12782, 0.63456, 0.96529, 0.46702], -[12783, 0.62406, 0.93951, 0.24801], -[12784, 0.89741, 0.66667, 0.20682], -[12785, 0.79357, 0.75728, 0.13592], -[12786, 0.76754, 0.73888, 0.05192], -[12787, 0.92303, 0.65888, 0.27698], -[12788, 0.91247, 0.53631, 0.03544], -[12789, 0.90372, 0.53111, 0.01271], -[12790, 0.85000, 0.78349, 0.50000], -[12791, 0.57564, 0.98276, 0.30200], -[12792, 0.70560, 0.79096, 0.03856], -[12793, 0.94991, 0.63213, 0.31403], -[12794, 0.64139, 0.94990, 0.34868], -[12795, 0.61872, 0.91516, 0.15901], -[12796, 0.82476, 0.63750, 0.00000], -[12797, 0.74608, 0.85537, 0.28000], -[12798, 0.52369, 1.00000, 0.25000], -[12799, 0.93515, 0.59764, 0.17583], -[12800, 0.72372, 0.76250, 0.01875], -[12801, 0.83744, 0.78199, 0.34511], -[12802, 0.68516, 0.91626, 0.33315], -[12803, 0.87903, 0.64521, 0.11551], -[12804, 0.94394, 0.60703, 0.22184], -[12805, 0.96533, 0.61501, 0.33624], -[12806, 0.73831, 0.76752, 0.04967], -[12807, 0.96759, 0.51762, 0.13547], -[12808, 0.77781, 0.73072, 0.05492], -[12809, 0.81769, 0.80336, 0.34806], -[12810, 0.56699, 1.00000, 0.37500], -[12811, 0.92497, 0.55753, 0.08683], -[12812, 0.67111, 0.88266, 0.17180], -[12813, 0.85472, 0.73218, 0.23421], -[12814, 0.55635, 0.92290, 0.08044], -[12815, 0.93615, 0.51863, 0.06182], -[12816, 0.94394, 0.61899, 0.24859], -[12817, 0.77140, 0.85881, 0.42973], -[12818, 0.91329, 0.62708, 0.16799], -[12819, 0.84595, 0.74496, 0.24121], -[12820, 0.37010, 0.97500, 0.00000], -[12821, 0.97500, 0.37010, 0.00000], -[12822, 0.83496, 0.79908, 0.45501], -[12823, 0.97674, 0.57115, 0.26021], -[12824, 0.78347, 0.75894, 0.11536], -[12825, 0.65000, 0.95670, 0.50000], -[12826, 0.67305, 0.86861, 0.13899], -[12827, 0.60306, 0.98462, 0.43162], -[12828, 0.81370, 0.73834, 0.13862], -[12829, 0.95102, 0.65036, 0.39753], -[12830, 0.77590, 0.84778, 0.36850], -[12831, 0.79670, 0.80164, 0.25366], -[12832, 1.00000, 0.56495, 0.36250], -[12833, 0.73587, 0.88618, 0.39376], -[12834, 0.45466, 1.00000, 0.13750], -[12835, 0.55653, 0.89473, 0.02260], -[12836, 0.65895, 0.92621, 0.28519], -[12837, 0.95903, 0.53827, 0.14074], -[12838, 0.50000, 0.97835, 0.13750], -[12839, 0.55293, 0.98188, 0.23769], -[12840, 0.65496, 0.88122, 0.13508], -[12841, 0.53042, 0.98851, 0.21679], -[12842, 0.73816, 0.73750, 0.00000], -[12843, 0.88553, 0.72183, 0.31654], -[12844, 0.69980, 0.83179, 0.10329], -[12845, 0.55045, 0.95443, 0.14632], -[12846, 0.87107, 0.75972, 0.44435], -[12847, 0.73750, 0.89175, 0.50000], -[12848, 0.89212, 0.62379, 0.10730], -[12849, 0.79306, 0.82815, 0.34340], -[12850, 0.80235, 0.71024, 0.06287], -[12851, 0.96725, 0.57890, 0.23798], -[12852, 0.41136, 1.00000, 0.08750], -[12853, 1.00000, 0.43505, 0.11250], -[12854, 1.00000, 0.37010, 0.05000], -[12855, 0.69311, 0.88965, 0.23983], -[12856, 0.97538, 0.62252, 0.47319], -[12857, 0.53788, 0.92849, 0.06582], -[12858, 0.93554, 0.56401, 0.11713], -[12859, 0.71224, 0.89762, 0.33572], -[12860, 1.00000, 0.30000, 0.00000], -[12861, 0.30000, 1.00000, 0.00000], -[12862, 1.00000, 0.50000, 0.20000], -[12863, 0.50000, 1.00000, 0.20000], -[12864, 0.78750, 0.84845, 0.50000], -[12865, 0.75228, 0.83521, 0.22333], -[12866, 0.93295, 0.53871, 0.07637], -[12867, 0.70743, 0.88967, 0.28064], -[12868, 0.93514, 0.62610, 0.22862], -[12869, 0.90249, 0.60469, 0.09989], -[12870, 0.85593, 0.61111, 0.01605], -[12871, 0.61729, 0.86770, 0.04577], -[12872, 0.90127, 0.55255, 0.02805], -[12873, 0.96406, 0.54482, 0.16216], -[12874, 0.61387, 0.98089, 0.46245], -[12875, 0.95051, 0.51788, 0.08904], -[12876, 0.86832, 0.73992, 0.30203], -[12877, 0.91213, 0.70659, 0.40295], -[12878, 0.77435, 0.85955, 0.45250], -[12879, 0.64939, 0.95325, 0.39827], -[12880, 0.82705, 0.69816, 0.08837], -[12881, 0.78268, 0.85259, 0.46191], -[12882, 0.84746, 0.69069, 0.11828], -[12883, 0.94278, 0.56293, 0.13222], -[12884, 0.79156, 0.81545, 0.27759], -[12885, 1.00000, 0.52165, 0.23750], -[12886, 0.72126, 0.84174, 0.16475], -[12887, 0.60491, 0.97739, 0.35855], -[12888, 0.92500, 0.69689, 0.50000], -[12889, 0.80824, 0.68658, 0.03438], -[12890, 0.78101, 0.84802, 0.38876], -[12891, 0.82010, 0.79393, 0.30347], -[12892, 0.88727, 0.73974, 0.41601], -[12893, 0.75899, 0.86380, 0.36108], -[12894, 0.68111, 0.93554, 0.45007], -[12895, 0.97136, 0.62915, 0.45136], -[12896, 0.62584, 0.96750, 0.38150], -[12897, 0.92671, 0.68736, 0.39738], -[12898, 0.98959, 0.54222, 0.23830], -[12899, 0.87942, 0.75376, 0.48189], -[12900, 0.85786, 0.68926, 0.13824], -[12901, 0.61052, 0.97849, 0.39173], -[12902, 0.65197, 0.83023, 0.02286], -[12903, 0.98068, 0.52918, 0.18336], -[12904, 0.51517, 0.97541, 0.14611], -[12905, 0.90797, 0.61949, 0.13406], -[12906, 0.69255, 0.87966, 0.20220], -[12907, 0.72193, 0.85519, 0.20050], -[12908, 0.94943, 0.65858, 0.41574], -[12909, 0.69009, 0.85507, 0.13269], -[12910, 0.80561, 0.76738, 0.17678], -[12911, 0.98171, 0.58501, 0.30928], -[12912, 0.54534, 1.00000, 0.28750], -[12913, 0.89877, 0.59755, 0.07838], -[12914, 1.00000, 0.47835, 0.16250], -[12915, 1.00000, 0.33750, 0.02165], -[12916, 0.76528, 0.72650, 0.02112], -[12917, 0.89391, 0.70268, 0.27644], -[12918, 0.62896, 0.89332, 0.11370], -[12919, 0.98885, 0.52936, 0.20878], -[12920, 0.71926, 0.90849, 0.48599], -[12921, 0.87468, 0.66345, 0.12875], -[12922, 0.60776, 0.93062, 0.17190], -[12923, 0.86407, 0.70556, 0.18588], -[12924, 0.68979, 0.80137, 0.02556], -[12925, 0.67321, 0.80000, 0.00000], -[12926, 0.96049, 0.64702, 0.45504], -[12927, 0.80445, 0.81072, 0.30266], -[12928, 0.65022, 0.89459, 0.15314], -[12929, 0.73918, 0.75848, 0.02913], -[12930, 0.57098, 0.89185, 0.02880], -[12931, 0.93198, 0.58516, 0.13597], -[12932, 0.89728, 0.73239, 0.45458], -[12933, 0.78947, 0.78093, 0.16765], -[12934, 0.77447, 0.74723, 0.06924], -[12935, 0.89876, 0.71623, 0.34846], -[12936, 0.97901, 0.56261, 0.23780], -[12937, 0.97631, 0.50000, 0.12500], -[12938, 0.67173, 0.94467, 0.48470], -[12939, 0.80330, 0.78485, 0.21249], -[12940, 0.80366, 0.81917, 0.33557], -[12941, 0.56699, 1.00000, 0.35000], -[12942, 0.69934, 0.91217, 0.34885], -[12943, 0.75151, 0.79592, 0.11822], -[12944, 0.64473, 0.88371, 0.11606], -[12945, 0.74149, 0.87564, 0.33425], -[12946, 0.88971, 0.55000, 0.00000], -[12947, 0.97012, 0.63480, 0.50000], -[12948, 0.97392, 0.61615, 0.37352], -[12949, 0.94906, 0.62543, 0.27096], -[12950, 0.59919, 0.97646, 0.32093], -[12951, 1.00000, 0.58655, 0.47685], -[12952, 0.72237, 0.88208, 0.28837], -[12953, 0.90820, 0.70139, 0.33243], -[12954, 1.00000, 0.39175, 0.06250], -[12955, 0.87453, 0.76044, 0.45739], -[12956, 0.85466, 0.70093, 0.14899], -[12957, 0.82123, 0.74472, 0.15936], -[12958, 0.84592, 0.66547, 0.06796], -[12959, 0.65369, 0.95779, 0.47728], -[12960, 0.91395, 0.65636, 0.21879], -[12961, 0.75413, 0.80441, 0.14022], -[12962, 0.94118, 0.67533, 0.44146], -[12963, 0.97600, 0.61709, 0.38972], -[12964, 1.00000, 0.56495, 0.33750], -[12965, 0.76791, 0.86358, 0.39942], -[12966, 0.34641, 1.00000, 0.02500], -[12967, 0.58203, 0.97942, 0.28143], -[12968, 1.00000, 0.54330, 0.27500], -[12969, 0.60535, 0.86800, 0.02466], -[12970, 0.50000, 0.95670, 0.07500], -[12971, 0.76018, 0.85982, 0.33049], -[12972, 0.73150, 0.88782, 0.34894], -[12973, 0.93301, 0.50000, 0.02500], -[12974, 0.50000, 0.93575, 0.03036], -[12975, 0.52904, 0.97594, 0.16254], -[12976, 0.93667, 0.65296, 0.29375], -[12977, 0.74365, 0.79617, 0.10070], -[12978, 0.92891, 0.61868, 0.18258], -[12979, 0.70116, 0.91877, 0.39690], -[12980, 0.63987, 0.90784, 0.16411], -[12981, 0.89451, 0.71048, 0.29629], -[12982, 0.94484, 0.64766, 0.31453], -[12983, 1.00000, 0.58660, 0.45000], -[12984, 0.88687, 0.70115, 0.23834], -[12985, 0.67817, 0.91235, 0.26683], -[12986, 0.57337, 0.94990, 0.15976], -[12987, 0.56214, 0.96213, 0.17563], -[12988, 0.88848, 0.67120, 0.17284], -[12989, 0.68750, 0.93505, 0.50000], -[12990, 0.80730, 0.83129, 0.43524], -[12991, 0.58831, 1.00000, 0.46964], -[12992, 0.82671, 0.81236, 0.43947], -[12993, 0.89005, 0.67908, 0.19366], -[12994, 0.92319, 0.70066, 0.43619], -[12995, 0.71910, 0.90721, 0.41538], -[12996, 0.88989, 0.68833, 0.21434], -[12997, 0.94889, 0.65660, 0.37370], -[12998, 0.71950, 0.83204, 0.12919], -[12999, 0.43301, 1.00000, 0.10000], -[13000, 0.70368, 0.92299, 0.47737], -[13001, 0.65603, 0.85759, 0.07367], -[13002, 0.95219, 0.66378, 0.47785], -[13003, 0.94201, 0.54545, 0.09637], -[13004, 0.94349, 0.66005, 0.35164], -[13005, 0.77839, 0.76117, 0.09663], -[13006, 0.91686, 0.51306, 0.00586], -[13007, 0.73650, 0.78492, 0.06455], -[13008, 0.75171, 0.82483, 0.17941], -[13009, 0.85507, 0.64808, 0.05608], -[13010, 0.96600, 0.56934, 0.19843], -[13011, 0.86847, 0.61912, 0.04094], -[13012, 0.98262, 0.58010, 0.28478], -[13013, 0.56147, 0.97947, 0.22826], -[13014, 0.73178, 0.89912, 0.43226], -[13015, 0.79665, 0.83594, 0.37706], -[13016, 0.72787, 0.86532, 0.23541], -[13017, 0.76978, 0.73664, 0.03796], -[13018, 0.86806, 0.58750, 0.00000], -[13019, 0.73991, 0.83000, 0.16475], -[13020, 0.82899, 0.66180, 0.02720], -[13021, 0.90948, 0.72171, 0.47084], -[13022, 0.96530, 0.61726, 0.31002], -[13023, 0.62524, 0.85712, 0.02740], -[13024, 0.84236, 0.74774, 0.21672], -[13025, 0.91250, 0.71854, 0.50000], -[13026, 0.82055, 0.81707, 0.41022], -[13027, 0.70007, 0.81881, 0.06586], -[13028, 0.52674, 0.95585, 0.10256], -[13029, 1.00000, 0.45670, 0.12500], -[13030, 0.86939, 0.73422, 0.26687], -[13031, 0.91720, 0.70327, 0.38397], -[13032, 0.76417, 0.86220, 0.35159], -[13033, 0.47631, 1.00000, 0.15000], -[13034, 0.85939, 0.74232, 0.25540], -[13035, 0.88874, 0.61657, 0.07632], -[13036, 0.63464, 0.88611, 0.09803], -[13037, 0.83750, 0.80514, 0.50000], -[13038, 0.67011, 0.90442, 0.21246], -[13039, 1.00000, 0.58660, 0.42500], -[13040, 0.62353, 0.95434, 0.27575], -[13041, 0.60683, 0.96028, 0.25615], -[13042, 0.52369, 1.00000, 0.22500], -[13043, 0.89958, 0.64678, 0.15016], -[13044, 0.74359, 0.82024, 0.14743], -[13045, 0.67776, 0.93164, 0.34927], -[13046, 0.66733, 0.94564, 0.39722], -[13047, 0.81303, 0.82932, 0.46334], -[13048, 0.60210, 0.91896, 0.12152], -[13049, 0.93859, 0.64347, 0.26488], -[13050, 0.87048, 0.76961, 0.48391], -[13051, 0.91156, 0.71680, 0.42536], -[13052, 0.73134, 0.79999, 0.08109], -[13053, 0.71767, 0.80018, 0.05842], -[13054, 0.58864, 1.00000, 0.43750], -[13055, 0.63058, 0.97108, 0.40009], -[13056, 0.80311, 0.67500, 0.00000], -[13057, 0.96298, 0.63855, 0.37536], -[13058, 0.94350, 0.60638, 0.19535], -[13059, 0.93988, 0.66199, 0.32906], -[13060, 0.72081, 0.88312, 0.27325], -[13061, 0.83493, 0.64708, 0.01505], -[13062, 0.93980, 0.67414, 0.38469], -[13063, 0.84672, 0.64647, 0.03474], -[13064, 0.83811, 0.69859, 0.09890], -[13065, 1.00000, 0.41340, 0.07500], -[13066, 0.77978, 0.81034, 0.20523], -[13067, 0.52086, 0.94465, 0.06643], -[13068, 0.72894, 0.88854, 0.32408], -[13069, 0.85551, 0.77958, 0.38959], -[13070, 0.77359, 0.85406, 0.34463], -[13071, 0.82455, 0.75633, 0.18359], -[13072, 0.70349, 0.92255, 0.42203], -[13073, 0.56699, 1.00000, 0.32500], -[13074, 0.36922, 1.00000, 0.03542], -[13075, 0.83480, 0.76622, 0.23880], -[13076, 0.86544, 0.74487, 0.27993], -[13077, 0.86513, 0.77564, 0.45272], -[13078, 0.93183, 0.63327, 0.21153], -[13079, 0.90171, 0.63236, 0.12632], -[13080, 0.76262, 0.87620, 0.44189], -[13081, 0.85112, 0.79256, 0.48821], -[13082, 0.95466, 0.50000, 0.06250], -[13083, 0.63360, 0.92377, 0.18686], -[13084, 0.68723, 0.93816, 0.47903], -[13085, 0.84373, 0.77343, 0.29305], -[13086, 0.75981, 0.72500, 0.00000], -[13087, 0.69486, 0.78750, 0.00000], -[13088, 0.70619, 0.85407, 0.14665], -[13089, 0.73456, 0.90148, 0.47036], -[13090, 0.63027, 0.97499, 0.42737], -[13091, 0.97180, 0.57153, 0.21325], -[13092, 0.86932, 0.72084, 0.22058], -[13093, 0.86390, 0.65398, 0.07644], -[13094, 0.75472, 0.87690, 0.37801], -[13095, 0.92392, 0.70601, 0.46232], -[13096, 0.65350, 0.96146, 0.45461], -[13097, 0.88172, 0.67980, 0.16236], -[13098, 0.80055, 0.70708, 0.03866], -[13099, 0.54534, 1.00000, 0.26250], -[13100, 0.58369, 0.91682, 0.08448], -[13101, 0.66905, 0.86109, 0.09394], -[13102, 0.55138, 0.95332, 0.12422], -[13103, 0.85617, 0.77576, 0.36140], -[13104, 1.00000, 0.58660, 0.40000], -[13105, 0.58864, 1.00000, 0.41250], -[13106, 1.00000, 0.56495, 0.31250], -[13107, 0.38971, 1.00000, 0.05000], -[13108, 0.80554, 0.68678, 0.01643], -[13109, 0.88392, 0.74525, 0.36699], -[13110, 0.82675, 0.80943, 0.37467], -[13111, 0.93584, 0.67819, 0.36322], -[13112, 0.98125, 0.62269, 0.43750], -[13113, 0.88004, 0.75342, 0.38810], -[13114, 0.52165, 0.91250, 0.00000], -[13115, 1.00000, 0.52165, 0.21250], -[13116, 0.57662, 0.97250, 0.22329], -[13117, 0.60181, 0.88322, 0.03893], -[13118, 0.90426, 0.72716, 0.40839], -[13119, 0.92223, 0.71002, 0.48303], -[13120, 0.57939, 0.88750, 0.01875], -[13121, 0.77406, 0.85113, 0.32261], -[13122, 0.78753, 0.85256, 0.41031], -[13123, 0.80866, 0.75923, 0.14675], -[13124, 0.54330, 0.90000, 0.00000], -[13125, 0.77520, 0.86825, 0.47695], -[13126, 0.89852, 0.74012, 0.47909], -[13127, 0.96799, 0.60642, 0.27447], -[13128, 1.00000, 0.32500, 0.00000], -[13129, 0.32500, 1.00000, 0.00000], -[13130, 0.50000, 0.92500, 0.00000], -[13131, 0.92500, 0.50000, 0.00000], -[13132, 1.00000, 0.50000, 0.17500], -[13133, 0.50000, 1.00000, 0.17500], -[13134, 0.86170, 0.68219, 0.11555], -[13135, 0.85374, 0.79098, 0.46545], -[13136, 0.70862, 0.86478, 0.17465], -[13137, 0.93587, 0.69172, 0.46042], -[13138, 0.58467, 0.97663, 0.25455], -[13139, 0.61466, 0.94698, 0.21472], -[13140, 0.67110, 0.84462, 0.06146], -[13141, 0.68089, 0.93536, 0.36670], -[13142, 0.92473, 0.66407, 0.25467], -[13143, 0.52427, 0.93149, 0.03765], -[13144, 0.84908, 0.79293, 0.41848], -[13145, 0.66145, 0.95500, 0.41773], -[13146, 0.74360, 0.85099, 0.21834], -[13147, 0.95978, 0.56966, 0.16714], -[13148, 0.54033, 0.98603, 0.19621], -[13149, 0.64597, 0.95460, 0.33241], -[13150, 0.88061, 0.58454, 0.01061], -[13151, 0.56495, 0.88750, 0.00000], -[13152, 0.45466, 1.00000, 0.11250], -[13153, 0.67892, 0.82961, 0.04420], -[13154, 0.56078, 0.93482, 0.08937], -[13155, 0.84641, 0.62500, 0.00000], -[13156, 0.63262, 0.93881, 0.22528], -[13157, 0.87274, 0.75391, 0.33557], -[13158, 0.95463, 0.64704, 0.33529], -[13159, 0.63706, 0.84533, 0.01342], -[13160, 0.64615, 0.95069, 0.31055], -[13161, 0.73533, 0.81363, 0.10687], -[13162, 0.50000, 0.97835, 0.11250], -[13163, 0.74762, 0.83899, 0.19240], -[13164, 0.93028, 0.61374, 0.16019], -[13165, 1.00000, 0.54330, 0.25000], -[13166, 0.77500, 0.87010, 0.50000], -[13167, 0.92406, 0.69592, 0.36036], -[13168, 0.47835, 0.93750, 0.00000], -[13169, 0.93750, 0.47835, 0.00000], -[13170, 0.83148, 0.75926, 0.20004], -[13171, 0.90000, 0.74019, 0.50000], -[13172, 0.64858, 0.93276, 0.24063], -[13173, 0.64437, 0.85439, 0.03870], -[13174, 0.76548, 0.75455, 0.04968], -[13175, 0.66400, 0.93756, 0.30450], -[13176, 0.71827, 0.90858, 0.37069], -[13177, 0.59517, 0.94392, 0.16377], -[13178, 0.58635, 0.94173, 0.14274], -[13179, 0.62809, 0.88107, 0.06684], -[13180, 0.78507, 0.77742, 0.12890], -[13181, 0.66559, 0.89797, 0.16973], -[13182, 0.98074, 0.55283, 0.19833], -[13183, 0.87671, 0.60178, 0.02275], -[13184, 0.97066, 0.51617, 0.11276], -[13185, 0.85300, 0.79227, 0.44254], -[13186, 0.83474, 0.73230, 0.14556], -[13187, 0.95500, 0.58732, 0.18102], -[13188, 0.97117, 0.62808, 0.35453], -[13189, 0.68879, 0.85458, 0.10734], -[13190, 0.88569, 0.63768, 0.09018], -[13191, 0.58864, 1.00000, 0.38750], -[13192, 0.59139, 0.98481, 0.30102], -[13193, 0.60138, 0.96279, 0.23428], -[13194, 0.81832, 0.69866, 0.05111], -[13195, 1.00000, 0.43505, 0.08750], -[13196, 0.77632, 0.80017, 0.15859], -[13197, 0.54835, 0.97584, 0.17349], -[13198, 0.68178, 0.81719, 0.02361], -[13199, 0.92317, 0.64079, 0.18897], -[13200, 0.73308, 0.88517, 0.30332], -[13201, 0.58660, 0.87500, 0.00000], -[13202, 1.00000, 0.58660, 0.37500], -[13203, 0.94955, 0.55553, 0.11337], -[13204, 0.73497, 0.89554, 0.36716], -[13205, 0.60752, 0.89924, 0.07323], -[13206, 0.72500, 0.91340, 0.50000], -[13207, 0.84259, 0.78441, 0.31372], -[13208, 1.00000, 0.60000, 0.50000], -[13209, 0.60000, 1.00000, 0.50000], -[13210, 0.84586, 0.68769, 0.08561], -[13211, 0.94573, 0.67761, 0.41902], -[13212, 0.92718, 0.55715, 0.06398], -[13213, 0.99165, 0.61366, 0.48439], -[13214, 0.89647, 0.60411, 0.06228], -[13215, 0.77905, 0.84098, 0.28540], -[13216, 1.00000, 0.47835, 0.13750], -[13217, 0.54220, 0.94533, 0.08439], -[13218, 0.60415, 0.98406, 0.33563], -[13219, 0.79652, 0.73806, 0.07426], -[13220, 0.72173, 0.90373, 0.34859], -[13221, 0.75973, 0.86540, 0.31431], -[13222, 0.91288, 0.69773, 0.29893], -[13223, 0.41136, 1.00000, 0.06250], -[13224, 0.83848, 0.74434, 0.17817], -[13225, 0.79256, 0.83270, 0.30202], -[13226, 0.78594, 0.72185, 0.02885], -[13227, 0.57158, 0.91871, 0.06408], -[13228, 0.75520, 0.88408, 0.40599], -[13229, 0.61646, 0.92159, 0.13746], -[13230, 0.71639, 0.87940, 0.22749], -[13231, 0.98056, 0.61355, 0.34836], -[13232, 0.61851, 0.95261, 0.23363], -[13233, 0.51947, 0.98916, 0.16421], -[13234, 0.71418, 0.87525, 0.20854], -[13235, 0.45670, 0.95000, 0.00000], -[13236, 0.95000, 0.45670, 0.00000], -[13237, 0.72630, 0.90601, 0.38726], -[13238, 0.57664, 0.90456, 0.04126], -[13239, 0.86974, 0.60158, 0.00716], -[13240, 0.88635, 0.60473, 0.04168], -[13241, 0.52021, 0.96985, 0.11247], -[13242, 0.56699, 1.00000, 0.30000], -[13243, 0.67472, 0.88518, 0.14969], -[13244, 0.83420, 0.69064, 0.06562], -[13245, 0.68764, 0.90761, 0.24511], -[13246, 0.90293, 0.68853, 0.23107], -[13247, 0.66542, 0.94411, 0.33397], -[13248, 0.76845, 0.84151, 0.24862], -[13249, 0.70860, 0.84483, 0.11789], -[13250, 0.74506, 0.89699, 0.45245], -[13251, 0.81391, 0.82994, 0.39621], -[13252, 0.60061, 0.91554, 0.09574], -[13253, 0.69850, 0.90544, 0.26610], -[13254, 0.51760, 0.92628, 0.01363], -[13255, 0.91169, 0.53036, 0.00000], -[13256, 0.78786, 0.82428, 0.25039], -[13257, 0.86685, 0.63381, 0.04248], -[13258, 0.89396, 0.74969, 0.46323], -[13259, 0.68184, 0.89065, 0.17691], -[13260, 1.00000, 0.37010, 0.02500], -[13261, 0.66214, 0.84509, 0.04174], -[13262, 0.98701, 0.60825, 0.36394], -[13263, 0.71958, 0.89509, 0.29080], -[13264, 0.59012, 0.95795, 0.18876], -[13265, 0.76765, 0.81722, 0.17488], -[13266, 0.84699, 0.71350, 0.13069], -[13267, 0.82337, 0.67622, 0.02287], -[13268, 0.88230, 0.75844, 0.40410], -[13269, 0.93479, 0.69416, 0.41424], -[13270, 0.84946, 0.74097, 0.19595], -[13271, 0.87988, 0.72489, 0.24811], -[13272, 0.85752, 0.77488, 0.33463], -[13273, 0.96480, 0.65390, 0.43120], -[13274, 0.87992, 0.70734, 0.20240], -[13275, 0.97631, 0.50000, 0.10000], -[13276, 0.81651, 0.73169, 0.09844], -[13277, 0.64327, 0.87062, 0.06219], -[13278, 0.63750, 0.97835, 0.50000], -[13279, 0.95927, 0.63227, 0.29095], -[13280, 0.60825, 0.86250, 0.00000], -[13281, 0.61909, 0.90866, 0.10636], -[13282, 0.92810, 0.59600, 0.11610], -[13283, 0.71651, 0.77500, 0.00000], -[13284, 0.70080, 0.89876, 0.24468], -[13285, 0.78718, 0.80086, 0.17881], -[13286, 0.82500, 0.82679, 0.50000], -[13287, 0.87604, 0.65558, 0.09132], -[13288, 0.84233, 0.80874, 0.47449], -[13289, 0.52369, 1.00000, 0.20000], -[13290, 1.00000, 0.56495, 0.28750], -[13291, 0.90153, 0.73054, 0.36620], -[13292, 0.62936, 0.98381, 0.48065], -[13293, 0.80225, 0.74592, 0.09395], -[13294, 0.82055, 0.75953, 0.16120], -[13295, 0.92550, 0.70856, 0.41991], -[13296, 0.94267, 0.59782, 0.15461], -[13297, 0.65793, 0.95794, 0.37816], -[13298, 0.68721, 0.84884, 0.08454], -[13299, 0.58864, 1.00000, 0.36250], -[13300, 0.93036, 0.60654, 0.13676], -[13301, 0.54230, 0.92773, 0.04095], -[13302, 0.70710, 0.91112, 0.31193], -[13303, 0.57693, 0.93584, 0.10386], -[13304, 0.76535, 0.83114, 0.20162], -[13305, 0.86563, 0.72483, 0.19826], -[13306, 0.67077, 0.90522, 0.18931], -[13307, 0.71266, 0.79211, 0.01979], -[13308, 0.88990, 0.74265, 0.34991], -[13309, 0.94125, 0.64227, 0.24008], -[13310, 0.82379, 0.78333, 0.22816], -[13311, 0.67139, 0.92227, 0.24522], -[13312, 0.54534, 1.00000, 0.23750], -[13313, 0.65109, 0.94755, 0.28834], -[13314, 1.00000, 0.58660, 0.35000], -[13315, 0.75290, 0.89136, 0.42765], -[13316, 0.94856, 0.68305, 0.48125], -[13317, 0.91459, 0.71281, 0.35116], -[13318, 0.91426, 0.59142, 0.07400], -[13319, 0.79498, 0.85720, 0.48074], -[13320, 0.79186, 0.78362, 0.14497], -[13321, 0.62622, 0.97611, 0.35070], -[13322, 0.73211, 0.85373, 0.17989], -[13323, 0.57698, 0.94423, 0.12195], -[13324, 0.71061, 0.89642, 0.25737], -[13325, 0.80727, 0.84171, 0.41478], -[13326, 0.47631, 1.00000, 0.12500], -[13327, 0.56116, 0.93440, 0.07623], -[13328, 0.76434, 0.87130, 0.34423], -[13329, 0.89990, 0.57498, 0.02331], -[13330, 0.50000, 0.95670, 0.05000], -[13331, 0.71247, 0.92619, 0.45122], -[13332, 0.60448, 0.95700, 0.20572], -[13333, 0.86969, 0.77074, 0.36787], -[13334, 0.62989, 0.96905, 0.32052], -[13335, 0.88750, 0.76184, 0.50000], -[13336, 0.66822, 0.94866, 0.35292], -[13337, 0.86114, 0.76763, 0.30687], -[13338, 0.43301, 1.00000, 0.07500], -[13339, 0.70581, 0.91759, 0.33267], -[13340, 0.73702, 0.87388, 0.25238], -[13341, 0.58525, 0.96972, 0.20786], -[13342, 0.98254, 0.53723, 0.16196], -[13343, 0.96494, 0.59847, 0.21890], -[13344, 0.78146, 0.71250, 0.00000], -[13345, 0.68764, 0.94026, 0.39311], -[13346, 0.65173, 0.96911, 0.43303], -[13347, 0.43330, 0.96473, 0.00000], -[13348, 0.96474, 0.43328, 0.00000], -[13349, 0.76548, 0.78842, 0.09887], -[13350, 0.80339, 0.83800, 0.35581], -[13351, 1.00000, 0.45670, 0.10000], -[13352, 0.97527, 0.63816, 0.39881], -[13353, 0.76280, 0.88633, 0.46489], -[13354, 0.61292, 0.97677, 0.30269], -[13355, 0.76658, 0.85903, 0.29218], -[13356, 0.91268, 0.67525, 0.21720], -[13357, 0.94422, 0.63187, 0.22045], -[13358, 0.85877, 0.72578, 0.17637], -[13359, 0.91951, 0.69054, 0.28380], -[13360, 0.82476, 0.66250, 0.00000], -[13361, 0.77636, 0.86727, 0.38058], -[13362, 0.97065, 0.62017, 0.29409], -[13363, 0.93512, 0.68063, 0.32256], -[13364, 0.60076, 0.89767, 0.05002], -[13365, 0.55639, 0.93019, 0.05910], -[13366, 0.84768, 0.79721, 0.37686], -[13367, 0.62990, 0.85000, 0.00000], -[13368, 0.71977, 0.83114, 0.09944], -[13369, 0.88502, 0.69416, 0.17709], -[13370, 0.76719, 0.85318, 0.26998], -[13371, 0.82991, 0.68424, 0.03891], -[13372, 1.00000, 0.60688, 0.46458], -[13373, 0.68602, 0.88396, 0.15704], -[13374, 0.70394, 0.92632, 0.37343], -[13375, 0.69291, 0.94061, 0.43105], -[13376, 0.78132, 0.77649, 0.10468], -[13377, 0.55439, 0.91704, 0.02944], -[13378, 1.00000, 0.52165, 0.18750], -[13379, 0.70259, 0.93512, 0.45869], -[13380, 0.81518, 0.83036, 0.37401], -[13381, 0.57000, 0.98011, 0.20937], -[13382, 0.72150, 0.84852, 0.13995], -[13383, 0.96582, 0.61336, 0.25269], -[13384, 0.73113, 0.91282, 0.45069], -[13385, 0.82762, 0.82028, 0.38861], -[13386, 0.53666, 0.97783, 0.14486], -[13387, 0.82432, 0.71100, 0.06952], -[13388, 1.00000, 0.39312, 0.03542], -[13389, 0.90887, 0.71394, 0.31387], -[13390, 0.91517, 0.72183, 0.39123], -[13391, 0.78633, 0.85588, 0.35967], -[13392, 0.84784, 0.66693, 0.04512], -[13393, 0.87428, 0.77513, 0.42655], -[13394, 0.85375, 0.72271, 0.15417], -[13395, 1.00000, 0.54330, 0.22500], -[13396, 0.79999, 0.71896, 0.03748], -[13397, 0.75083, 0.87510, 0.29676], -[13398, 0.67500, 0.95670, 0.50000], -[13399, 0.91174, 0.69723, 0.26869], -[13400, 0.93491, 0.53184, 0.03741], -[13401, 0.73658, 0.88226, 0.27619], -[13402, 0.83103, 0.78602, 0.24978], -[13403, 0.65513, 0.92297, 0.19992], -[13404, 0.68384, 0.86955, 0.11614], -[13405, 0.92667, 0.52965, 0.01838], -[13406, 0.95852, 0.67123, 0.45518], -[13407, 0.96429, 0.56186, 0.14491], -[13408, 0.82917, 0.82689, 0.47949], -[13409, 0.64013, 0.97953, 0.44989], -[13410, 0.65726, 0.94193, 0.27069], -[13411, 0.80420, 0.78952, 0.18102], -[13412, 0.64491, 0.93560, 0.21615], -[13413, 0.79360, 0.84339, 0.32460], -[13414, 0.75190, 0.86470, 0.25729], -[13415, 0.70468, 0.91150, 0.28888], -[13416, 0.56244, 0.91852, 0.03951], -[13417, 0.56699, 1.00000, 0.27500], -[13418, 0.90367, 0.58854, 0.04271], -[13419, 0.92235, 0.67088, 0.23287], -[13420, 0.88971, 0.57500, 0.00000], -[13421, 0.84356, 0.80732, 0.40594], -[13422, 0.68630, 0.90957, 0.22770], -[13423, 1.00000, 0.35000, 0.00000], -[13424, 0.35000, 1.00000, 0.00000], -[13425, 1.00000, 0.50000, 0.15000], -[13426, 0.50000, 1.00000, 0.15000], -[13427, 0.80879, 0.82770, 0.31748], -[13428, 0.73510, 0.78892, 0.04198], -[13429, 0.62932, 0.97994, 0.37252], -[13430, 0.81319, 0.84324, 0.48160], -[13431, 0.61575, 0.90744, 0.08753], -[13432, 0.83399, 0.82188, 0.45760], -[13433, 0.65074, 0.88143, 0.08475], -[13434, 0.82137, 0.78003, 0.20046], -[13435, 0.94295, 0.69500, 0.47456], -[13436, 0.41296, 0.97586, 0.00000], -[13437, 0.97592, 0.41283, 0.00000], -[13438, 0.56343, 0.97931, 0.18955], -[13439, 0.58864, 1.00000, 0.33750], -[13440, 0.80387, 0.80978, 0.23342], -[13441, 0.96798, 0.65996, 0.47633], -[13442, 0.92841, 0.69698, 0.34063], -[13443, 0.53523, 0.92530, 0.01988], -[13444, 0.64653, 0.90275, 0.12555], -[13445, 0.68716, 0.92343, 0.28007], -[13446, 0.91556, 0.56733, 0.03827], -[13447, 1.00000, 0.41340, 0.05000], -[13448, 0.94353, 0.66931, 0.31233], -[13449, 0.68719, 0.90194, 0.20364], -[13450, 0.55831, 0.99250, 0.22285], -[13451, 0.83879, 0.81503, 0.42402], -[13452, 0.61088, 1.00000, 0.47685], -[13453, 0.87002, 0.70993, 0.16414], -[13454, 0.63345, 0.92918, 0.16967], -[13455, 1.00000, 0.60825, 0.43750], -[13456, 0.70758, 0.83495, 0.08036], -[13457, 0.70884, 0.85773, 0.13141], -[13458, 0.97814, 0.64587, 0.48552], -[13459, 0.98464, 0.60195, 0.29428], -[13460, 0.90321, 0.66530, 0.15954], -[13461, 0.95752, 0.51986, 0.06726], -[13462, 0.91435, 0.66200, 0.18361], -[13463, 0.96416, 0.53585, 0.10289], -[13464, 0.80557, 0.85095, 0.46135], -[13465, 0.76052, 0.85044, 0.22971], -[13466, 1.00000, 0.58660, 0.32500], -[13467, 0.64862, 0.97264, 0.41055], -[13468, 0.70270, 0.89732, 0.22457], -[13469, 0.61029, 1.00000, 0.45000], -[13470, 0.96597, 0.63904, 0.31699], -[13471, 0.79301, 0.81896, 0.22535], -[13472, 0.81563, 0.84059, 0.44350], -[13473, 0.86587, 0.78539, 0.40781], -[13474, 0.92607, 0.69580, 0.31740], -[13475, 0.63355, 0.94085, 0.20243], -[13476, 0.84538, 0.71617, 0.11582], -[13477, 0.72102, 0.90802, 0.32448], -[13478, 0.93743, 0.69408, 0.37877], -[13479, 0.91914, 0.57679, 0.05519], -[13480, 0.66997, 0.83607, 0.02301], -[13481, 0.62126, 0.99047, 0.40811], -[13482, 0.82116, 0.80982, 0.28693], -[13483, 0.66722, 0.92214, 0.21717], -[13484, 0.69232, 0.84035, 0.06406], -[13485, 0.75066, 0.81970, 0.12566], -[13486, 1.00000, 0.56495, 0.26250], -[13487, 0.92704, 0.55304, 0.04138], -[13488, 0.91723, 0.64945, 0.16460], -[13489, 0.79925, 0.85629, 0.43993], -[13490, 0.86781, 0.67680, 0.09441], -[13491, 0.95389, 0.50000, 0.03542], -[13492, 0.98300, 0.53214, 0.14437], -[13493, 0.65155, 0.83750, 0.00000], -[13494, 0.73424, 0.83090, 0.11727], -[13495, 0.91838, 0.68564, 0.25001], -[13496, 0.75176, 0.88760, 0.34790], -[13497, 0.73816, 0.76250, 0.00000], -[13498, 0.93640, 0.64405, 0.20896], -[13499, 0.96440, 0.65264, 0.35730], -[13500, 0.75808, 0.88444, 0.36047], -[13501, 0.95817, 0.67702, 0.50000], -[13502, 0.57565, 0.98897, 0.24093], -[13503, 0.92498, 0.62998, 0.14775], -[13504, 0.89636, 0.65771, 0.12509], -[13505, 0.76250, 0.89175, 0.50000], -[13506, 0.77189, 0.88015, 0.42126], -[13507, 0.57164, 0.95885, 0.13869], -[13508, 0.93094, 0.68702, 0.30486], -[13509, 0.90401, 0.62407, 0.08766], -[13510, 0.71449, 0.91877, 0.35097], -[13511, 0.77427, 0.79511, 0.11901], -[13512, 0.62713, 0.96101, 0.25497], -[13513, 0.45466, 1.00000, 0.08750], -[13514, 0.76839, 0.87618, 0.36282], -[13515, 0.71727, 0.89173, 0.24059], -[13516, 0.95854, 0.66805, 0.39080], -[13517, 0.74958, 0.86347, 0.23624], -[13518, 0.81531, 0.75510, 0.12300], -[13519, 0.68638, 0.87919, 0.13534], -[13520, 0.50000, 0.97835, 0.08750], -[13521, 0.62360, 0.89927, 0.07594], -[13522, 0.83886, 0.77043, 0.21659], -[13523, 0.55800, 0.90798, 0.00827], -[13524, 1.00000, 0.60825, 0.41250], -[13525, 0.81803, 0.80806, 0.26425], -[13526, 0.92993, 0.57685, 0.07546], -[13527, 0.69548, 0.93287, 0.34551], -[13528, 0.90017, 0.74767, 0.40684], -[13529, 0.97413, 0.53613, 0.12357], -[13530, 0.63336, 0.91407, 0.12397], -[13531, 0.61029, 1.00000, 0.42500], -[13532, 0.98654, 0.61264, 0.32778], -[13533, 0.98216, 0.55534, 0.17559], -[13534, 0.91503, 0.62226, 0.10773], -[13535, 0.64544, 0.95085, 0.25962], -[13536, 0.92133, 0.72621, 0.45169], -[13537, 0.86806, 0.61250, 0.00000], -[13538, 0.38912, 1.00000, 0.02315], -[13539, 0.94559, 0.58042, 0.11538], -[13540, 1.00000, 0.47835, 0.11250], -[13541, 0.58926, 0.90086, 0.03069], -[13542, 0.82229, 0.82532, 0.35268], -[13543, 0.96266, 0.61607, 0.23010], -[13544, 0.98079, 0.64102, 0.42091], -[13545, 0.85635, 0.78986, 0.35199], -[13546, 0.89439, 0.70362, 0.20991], -[13547, 0.92293, 0.71489, 0.37223], -[13548, 0.86256, 0.67676, 0.07905], -[13549, 0.91530, 0.54908, 0.01005], -[13550, 0.95823, 0.58921, 0.16245], -[13551, 0.80332, 0.85017, 0.39380], -[13552, 0.75259, 0.76250, 0.01875], -[13553, 0.68639, 0.93737, 0.32796], -[13554, 0.89856, 0.75263, 0.42537], -[13555, 0.87500, 0.78349, 0.50000], -[13556, 0.72355, 0.92271, 0.43140], -[13557, 0.74028, 0.84616, 0.15982], -[13558, 0.72158, 0.92062, 0.39235], -[13559, 0.52369, 1.00000, 0.17500], -[13560, 0.86437, 0.74208, 0.21338], -[13561, 0.81250, 0.84845, 0.50000], -[13562, 0.54534, 1.00000, 0.21250], -[13563, 0.88947, 0.62416, 0.05353], -[13564, 0.95453, 0.58163, 0.13849], -[13565, 0.78115, 0.77667, 0.09152], -[13566, 0.58275, 0.96566, 0.17086], -[13567, 0.52127, 0.98572, 0.12959], -[13568, 1.00000, 0.43505, 0.06250], -[13569, 0.62336, 0.94424, 0.18292], -[13570, 0.79184, 0.73693, 0.04088], -[13571, 0.73657, 0.78090, 0.02192], -[13572, 0.79973, 0.80684, 0.19936], -[13573, 0.94638, 0.69321, 0.43077], -[13574, 0.52464, 0.96358, 0.07888], -[13575, 0.86243, 0.76155, 0.26038], -[13576, 0.97095, 0.58809, 0.19564], -[13577, 0.75304, 0.77185, 0.03260], -[13578, 0.79096, 0.75935, 0.07676], -[13579, 0.70393, 0.82117, 0.03991], -[13580, 0.58864, 1.00000, 0.31250], -[13581, 0.60452, 0.98439, 0.28274], -[13582, 0.81033, 0.77986, 0.15809], -[13583, 0.91847, 0.73353, 0.48836], -[13584, 0.75962, 0.83033, 0.16040], -[13585, 0.86628, 0.76520, 0.28569], -[13586, 0.88404, 0.66862, 0.10843], -[13587, 0.71250, 0.93505, 0.50000], -[13588, 0.90749, 0.74529, 0.44521], -[13589, 0.62139, 0.89010, 0.04876], -[13590, 0.78379, 0.86197, 0.34285], -[13591, 0.95751, 0.53823, 0.08103], -[13592, 0.75618, 0.78151, 0.05320], -[13593, 0.74659, 0.85582, 0.19587], -[13594, 0.78766, 0.82124, 0.20414], -[13595, 0.61029, 1.00000, 0.40000], -[13596, 0.69759, 0.92803, 0.31403], -[13597, 0.85913, 0.69692, 0.10161], -[13598, 0.63678, 0.92355, 0.14767], -[13599, 0.61944, 0.93743, 0.15344], -[13600, 0.95378, 0.51649, 0.04599], -[13601, 1.00000, 0.60825, 0.38750], -[13602, 0.97685, 0.59976, 0.23784], -[13603, 0.79637, 0.85556, 0.37135], -[13604, 0.66485, 0.95377, 0.32351], -[13605, 0.50573, 0.94436, 0.01480], -[13606, 0.97055, 0.65801, 0.40935], -[13607, 0.72779, 0.92342, 0.47078], -[13608, 0.87133, 0.62651, 0.01879], -[13609, 0.87466, 0.78588, 0.47344], -[13610, 0.77364, 0.77115, 0.06393], -[13611, 0.68613, 0.93255, 0.29279], -[13612, 0.87094, 0.78137, 0.38025], -[13613, 0.87637, 0.69738, 0.14048], -[13614, 0.53828, 0.96925, 0.10686], -[13615, 0.97631, 0.50000, 0.07500], -[13616, 0.67321, 0.82500, 0.00000], -[13617, 0.93088, 0.68114, 0.26874], -[13618, 0.56699, 1.00000, 0.25000], -[13619, 0.76578, 0.81817, 0.14193], -[13620, 1.00000, 0.58660, 0.30000], -[13621, 0.78110, 0.86837, 0.35848], -[13622, 0.60485, 0.94134, 0.13622], -[13623, 0.75504, 0.84266, 0.17727], -[13624, 0.94586, 0.55767, 0.07731], -[13625, 0.89357, 0.76353, 0.44492], -[13626, 0.78551, 0.79813, 0.13880], -[13627, 0.94041, 0.65754, 0.23957], -[13628, 0.60271, 0.88738, 0.01636], -[13629, 0.75470, 0.90254, 0.47767], -[13630, 0.78281, 0.75013, 0.04264], -[13631, 0.90128, 0.74732, 0.38187], -[13632, 0.82637, 0.83434, 0.42418], -[13633, 0.88782, 0.75035, 0.31658], -[13634, 0.85760, 0.64345, 0.01474], -[13635, 0.80311, 0.70000, 0.00000], -[13636, 0.90236, 0.72076, 0.27360], -[13637, 0.83806, 0.80593, 0.31778], -[13638, 1.00000, 0.54330, 0.20000], -[13639, 0.77679, 0.86702, 0.32641], -[13640, 0.51232, 0.98216, 0.10231], -[13641, 0.78534, 0.87453, 0.43901], -[13642, 0.94373, 0.54434, 0.05453], -[13643, 0.82434, 0.81768, 0.30664], -[13644, 0.93004, 0.65593, 0.19924], -[13645, 0.85093, 0.77493, 0.25263], -[13646, 0.65268, 0.97924, 0.46912], -[13647, 0.75028, 0.88823, 0.31559], -[13648, 0.62170, 0.88109, 0.02764], -[13649, 0.61756, 0.97501, 0.26768], -[13650, 1.00000, 0.52165, 0.16250], -[13651, 0.98877, 0.51870, 0.12666], -[13652, 0.88484, 0.76228, 0.35073], -[13653, 0.95915, 0.61738, 0.20800], -[13654, 0.94997, 0.67794, 0.34354], -[13655, 0.59338, 0.91698, 0.06001], -[13656, 0.79120, 0.86823, 0.41772], -[13657, 0.90045, 0.73325, 0.30473], -[13658, 0.87999, 0.75510, 0.29483], -[13659, 0.54311, 0.97411, 0.12201], -[13660, 0.94248, 0.57696, 0.09305], -[13661, 0.90527, 0.68218, 0.18071], -[13662, 0.47631, 1.00000, 0.10000], -[13663, 0.78372, 0.83868, 0.23668], -[13664, 0.81562, 0.73225, 0.06926], -[13665, 0.68331, 0.95903, 0.48045], -[13666, 0.73582, 0.80709, 0.05926], -[13667, 0.69790, 0.87811, 0.14085], -[13668, 0.87803, 0.64793, 0.05672], -[13669, 0.77475, 0.84240, 0.22177], -[13670, 0.83018, 0.75423, 0.14048], -[13671, 0.90450, 0.70133, 0.22181], -[13672, 0.65741, 0.85145, 0.02006], -[13673, 0.83674, 0.82720, 0.44339], -[13674, 0.75481, 0.89745, 0.38732], -[13675, 0.89574, 0.59752, 0.02200], -[13676, 0.98479, 0.64559, 0.46425], -[13677, 0.86534, 0.79622, 0.42806], -[13678, 1.00000, 0.56495, 0.23750], -[13679, 0.61029, 1.00000, 0.37500], -[13680, 0.90628, 0.73266, 0.32693], -[13681, 0.95000, 0.69689, 0.50000], -[13682, 0.86348, 0.71645, 0.14043], -[13683, 0.98143, 0.63249, 0.34170], -[13684, 0.94953, 0.69003, 0.39727], -[13685, 0.95901, 0.65415, 0.29783], -[13686, 0.90788, 0.70705, 0.24620], -[13687, 0.59533, 0.94175, 0.11625], -[13688, 0.65625, 0.92155, 0.16994], -[13689, 0.88562, 0.77736, 0.48406], -[13690, 1.00000, 0.60825, 0.36250], -[13691, 0.72854, 0.82407, 0.07686], -[13692, 0.84641, 0.65000, 0.00000], -[13693, 0.79971, 0.76509, 0.09490], -[13694, 0.97299, 0.58144, 0.17702], -[13695, 0.98340, 0.64720, 0.44288], -[13696, 1.00000, 0.45670, 0.07500], -[13697, 0.57077, 0.97255, 0.15708], -[13698, 0.88501, 0.77281, 0.40638], -[13699, 0.83431, 0.74180, 0.12194], -[13700, 0.78966, 0.86863, 0.39404], -[13701, 0.80060, 0.85152, 0.34713], -[13702, 0.94149, 0.63804, 0.19017], -[13703, 0.93674, 0.63231, 0.16497], -[13704, 0.70272, 0.94219, 0.41032], -[13705, 0.90495, 0.64206, 0.10190], -[13706, 0.75981, 0.75000, 0.00000], -[13707, 0.62528, 0.97785, 0.29343], -[13708, 0.78708, 0.85500, 0.30172], -[13709, 0.84373, 0.74916, 0.15831], -[13710, 0.53388, 0.94769, 0.04531], -[13711, 0.64974, 0.97755, 0.38947], -[13712, 0.43301, 1.00000, 0.05000], -[13713, 0.90174, 0.75928, 0.48066], -[13714, 0.41169, 1.00000, 0.03036], -[13715, 0.60422, 0.97235, 0.21767], -[13716, 0.67760, 0.86394, 0.07017], -[13717, 0.85430, 0.81146, 0.45508], -[13718, 0.75417, 0.79851, 0.07113], -[13719, 0.90141, 0.68154, 0.16339], -[13720, 0.76158, 0.80969, 0.10661], -[13721, 0.80427, 0.77268, 0.11724], -[13722, 0.97971, 0.55339, 0.14729], -[13723, 1.00000, 0.37500, 0.00000], -[13724, 0.37500, 1.00000, 0.00000], -[13725, 1.00000, 0.62500, 0.50000], -[13726, 0.62500, 1.00000, 0.50000], -[13727, 1.00000, 0.50000, 0.12500], -[13728, 0.50000, 1.00000, 0.12500], -[13729, 0.55255, 0.98125, 0.15000], -[13730, 0.85976, 0.80017, 0.39388], -[13731, 0.92910, 0.62294, 0.12657], -[13732, 0.97273, 0.52137, 0.08440], -[13733, 0.94562, 0.66413, 0.26420], -[13734, 0.78809, 0.84525, 0.26472], -[13735, 0.50000, 0.95670, 0.02500], -[13736, 0.69647, 0.89535, 0.17722], -[13737, 0.72665, 0.86463, 0.16043], -[13738, 0.81870, 0.80855, 0.24130], -[13739, 0.71048, 0.88428, 0.17714], -[13740, 0.67347, 0.94399, 0.28459], -[13741, 0.83132, 0.72647, 0.08498], -[13742, 0.66776, 0.96700, 0.39919], -[13743, 0.89124, 0.77180, 0.46562], -[13744, 0.90975, 0.65398, 0.13142], -[13745, 0.74315, 0.91585, 0.48608], -[13746, 0.94319, 0.67642, 0.28960], -[13747, 0.74618, 0.89873, 0.33585], -[13748, 0.86745, 0.70497, 0.12311], -[13749, 0.84681, 0.68402, 0.04550], -[13750, 0.84504, 0.66889, 0.02039], -[13751, 0.58864, 1.00000, 0.28750], -[13752, 0.95830, 0.67410, 0.36222], -[13753, 0.77913, 0.88488, 0.45854], -[13754, 0.60999, 0.95911, 0.18413], -[13755, 0.95912, 0.64922, 0.27546], -[13756, 0.67264, 0.96862, 0.46509], -[13757, 0.80368, 0.73705, 0.04967], -[13758, 0.85713, 0.77688, 0.26817], -[13759, 0.84647, 0.71326, 0.09164], -[13760, 0.86662, 0.66781, 0.05830], -[13761, 0.64216, 0.95473, 0.23879], -[13762, 0.61381, 0.93223, 0.11747], -[13763, 0.86250, 0.80514, 0.50000], -[13764, 0.77329, 0.88459, 0.39186], -[13765, 0.89717, 0.71612, 0.22709], -[13766, 0.67124, 0.89191, 0.11769], -[13767, 0.67874, 0.95646, 0.36991], -[13768, 0.81693, 0.80329, 0.21717], -[13769, 0.79343, 0.75504, 0.06061], -[13770, 0.82616, 0.77737, 0.17453], -[13771, 0.95931, 0.63638, 0.24007], -[13772, 0.73898, 0.91232, 0.37987], -[13773, 0.65301, 0.89915, 0.10250], -[13774, 0.69486, 0.81250, 0.00000], -[13775, 0.84394, 0.81051, 0.34533], -[13776, 0.93907, 0.70782, 0.39854], -[13777, 0.72198, 0.92940, 0.40952], -[13778, 0.87885, 0.74763, 0.25114], -[13779, 0.87997, 0.73891, 0.22993], -[13780, 0.61242, 0.97710, 0.24775], -[13781, 0.91786, 0.56275, 0.01589], -[13782, 0.54139, 0.95493, 0.06577], -[13783, 0.82672, 0.82490, 0.32752], -[13784, 0.74098, 0.91399, 0.40269], -[13785, 0.64413, 0.96814, 0.29576], -[13786, 0.66684, 0.97420, 0.48533], -[13787, 0.72770, 0.91524, 0.33607], -[13788, 0.81437, 0.83009, 0.29534], -[13789, 0.58120, 0.97906, 0.18728], -[13790, 0.56217, 0.95737, 0.09799], -[13791, 0.92945, 0.59803, 0.08432], -[13792, 0.89266, 0.73683, 0.26598], -[13793, 0.91091, 0.60350, 0.05216], -[13794, 0.74401, 0.87162, 0.21483], -[13795, 0.76739, 0.88862, 0.37319], -[13796, 1.00000, 0.58660, 0.27500], -[13797, 0.96235, 0.68143, 0.43442], -[13798, 0.83893, 0.80061, 0.27640], -[13799, 0.79927, 0.79995, 0.15931], -[13800, 0.78838, 0.82205, 0.18758], -[13801, 0.61029, 1.00000, 0.35000], -[13802, 0.54534, 1.00000, 0.18750], -[13803, 0.64136, 0.87394, 0.03092], -[13804, 0.98306, 0.64072, 0.36496], -[13805, 0.63984, 0.88317, 0.04634], -[13806, 0.93750, 0.71854, 0.50000], -[13807, 0.65535, 0.97255, 0.35849], -[13808, 0.98750, 0.63364, 0.36309], -[13809, 0.63032, 0.95774, 0.21548], -[13810, 0.91807, 0.74271, 0.46732], -[13811, 0.93216, 0.72518, 0.47192], -[13812, 0.68978, 0.92800, 0.25772], -[13813, 0.98618, 0.57541, 0.19651], -[13814, 0.94697, 0.60077, 0.12829], -[13815, 0.72958, 0.87344, 0.18266], -[13816, 0.85521, 0.79731, 0.33030], -[13817, 0.70639, 0.94660, 0.46907], -[13818, 0.84032, 0.80421, 0.29227], -[13819, 0.97835, 0.66250, 0.50000], -[13820, 0.66250, 0.97835, 0.50000], -[13821, 0.93301, 0.52500, 0.00000], -[13822, 0.72419, 0.90597, 0.27406], -[13823, 0.82024, 0.72148, 0.04950], -[13824, 1.00000, 0.60825, 0.33750], -[13825, 0.89751, 0.73719, 0.28230], -[13826, 0.95623, 0.69250, 0.44961], -[13827, 0.89539, 0.68226, 0.14038], -[13828, 0.80322, 0.72072, 0.01833], -[13829, 0.88063, 0.72081, 0.18135], -[13830, 0.59047, 0.96243, 0.15114], -[13831, 0.52369, 1.00000, 0.15000], -[13832, 0.75000, 0.91340, 0.50000], -[13833, 1.00000, 0.41296, 0.02414], -[13834, 0.91136, 0.56250, 0.00000], -[13835, 0.81233, 0.70504, 0.01007], -[13836, 0.56202, 0.94711, 0.07091], -[13837, 0.80000, 0.87010, 0.50000], -[13838, 0.56699, 1.00000, 0.22500], -[13839, 0.94714, 0.61525, 0.15135], -[13840, 0.96366, 0.66559, 0.34005], -[13841, 0.94483, 0.70755, 0.43742], -[13842, 0.71047, 0.88079, 0.15829], -[13843, 1.00000, 0.62990, 0.47500], -[13844, 0.91685, 0.68372, 0.20110], -[13845, 0.70223, 0.87164, 0.11976], -[13846, 0.73474, 0.91511, 0.35696], -[13847, 0.80003, 0.84440, 0.28830], -[13848, 0.89160, 0.76609, 0.37284], -[13849, 0.79669, 0.73597, 0.02918], -[13850, 0.80881, 0.82696, 0.25501], -[13851, 0.95643, 0.64953, 0.25209], -[13852, 0.45466, 1.00000, 0.06250], -[13853, 0.57683, 0.91160, 0.01582], -[13854, 0.96112, 0.66482, 0.31982], -[13855, 0.64290, 0.90024, 0.08191], -[13856, 0.50000, 0.97835, 0.06250], -[13857, 0.91050, 0.66447, 0.14204], -[13858, 0.68668, 0.96098, 0.43959], -[13859, 0.56108, 0.97312, 0.12978], -[13860, 0.91499, 0.72021, 0.29265], -[13861, 0.60453, 0.92505, 0.07840], -[13862, 1.00000, 0.47835, 0.08750], -[13863, 0.80782, 0.78400, 0.13690], -[13864, 0.87240, 0.79740, 0.45371], -[13865, 0.63078, 1.00000, 0.46458], -[13866, 0.97582, 0.62707, 0.26816], -[13867, 1.00000, 0.62990, 0.45000], -[13868, 0.89874, 0.63850, 0.07111], -[13869, 0.57564, 0.92949, 0.04807], -[13870, 0.63500, 0.91393, 0.09820], -[13871, 0.96629, 0.56838, 0.12156], -[13872, 0.85972, 0.76675, 0.22987], -[13873, 0.76499, 0.87374, 0.27322], -[13874, 0.96180, 0.55682, 0.09382], -[13875, 0.81091, 0.85223, 0.37251], -[13876, 0.69729, 0.94803, 0.37659], -[13877, 0.88894, 0.61935, 0.02415], -[13878, 0.71554, 0.93980, 0.42895], -[13879, 0.88357, 0.76770, 0.32613], -[13880, 0.72710, 0.88958, 0.21645], -[13881, 0.79244, 0.87868, 0.47934], -[13882, 0.96356, 0.68162, 0.41337], -[13883, 0.70850, 0.89792, 0.19609], -[13884, 0.67782, 0.90816, 0.15877], -[13885, 0.67607, 0.91742, 0.18078], -[13886, 0.91477, 0.73542, 0.34809], -[13887, 0.83998, 0.76501, 0.16843], -[13888, 0.74839, 0.91461, 0.43565], -[13889, 0.54330, 0.92500, 0.00000], -[13890, 1.00000, 0.54330, 0.17500], -[13891, 0.72323, 0.85571, 0.11845], -[13892, 0.90371, 0.72462, 0.25668], -[13893, 0.52165, 0.93750, 0.00000], -[13894, 0.89264, 0.69741, 0.15664], -[13895, 0.94377, 0.68805, 0.30775], -[13896, 0.97615, 0.66747, 0.44678], -[13897, 0.76538, 0.88740, 0.33286], -[13898, 0.68515, 0.96152, 0.41316], -[13899, 0.88971, 0.60000, 0.00000], -[13900, 0.95778, 0.68483, 0.37647], -[13901, 0.76321, 0.85909, 0.21514], -[13902, 0.98741, 0.62385, 0.30608], -[13903, 0.83736, 0.82683, 0.36960], -[13904, 0.56495, 0.91250, 0.00000], -[13905, 1.00000, 0.56495, 0.21250], -[13906, 0.58042, 0.94509, 0.08550], -[13907, 0.95721, 0.61127, 0.16517], -[13908, 1.00000, 0.62990, 0.42500], -[13909, 0.50000, 0.95000, 0.00000], -[13910, 0.95000, 0.50000, 0.00000], -[13911, 0.56561, 0.92275, 0.01916], -[13912, 0.64482, 0.94287, 0.18728], -[13913, 0.77139, 0.76123, 0.02233], -[13914, 0.92631, 0.71776, 0.32831], -[13915, 0.73809, 0.90769, 0.31531], -[13916, 0.82476, 0.68750, 0.00000], -[13917, 0.71155, 0.85634, 0.09592], -[13918, 0.58864, 1.00000, 0.26250], -[13919, 0.91834, 0.61209, 0.06996], -[13920, 0.57659, 0.93703, 0.06131], -[13921, 0.90483, 0.70128, 0.19588], -[13922, 0.98390, 0.59270, 0.21069], -[13923, 0.61029, 1.00000, 0.32500], -[13924, 0.59717, 0.93879, 0.09359], -[13925, 0.64244, 0.98147, 0.33520], -[13926, 0.70209, 0.82282, 0.01708], -[13927, 0.72210, 0.90455, 0.24794], -[13928, 0.75516, 0.83836, 0.13935], -[13929, 0.84355, 0.82663, 0.40880], -[13930, 0.94212, 0.71656, 0.45311], -[13931, 0.63194, 1.00000, 0.43750], -[13932, 0.71651, 0.80000, 0.00000], -[13933, 0.54656, 0.96581, 0.08532], -[13934, 0.92500, 0.74019, 0.50000], -[13935, 1.00000, 0.52165, 0.13750], -[13936, 0.96398, 0.61428, 0.18853], -[13937, 0.65238, 0.97187, 0.31686], -[13938, 0.71651, 0.90269, 0.22529], -[13939, 1.00000, 0.43330, 0.03527], -[13940, 0.66494, 0.96031, 0.30150], -[13941, 0.90450, 0.75236, 0.35970], -[13942, 0.82811, 0.84658, 0.46182], -[13943, 0.62587, 0.95081, 0.17096], -[13944, 0.84624, 0.78514, 0.23261], -[13945, 0.58660, 0.90000, 0.00000], -[13946, 0.98125, 0.61547, 0.25000], -[13947, 0.84693, 0.71065, 0.07352], -[13948, 0.76732, 0.85116, 0.19833], -[13949, 0.84143, 0.73758, 0.10975], -[13950, 0.78146, 0.73750, 0.00000], -[13951, 0.88471, 0.73269, 0.20833], -[13952, 0.82919, 0.70619, 0.03267], -[13953, 0.69507, 0.86741, 0.08866], -[13954, 0.80082, 0.87274, 0.45587], -[13955, 0.88280, 0.66689, 0.07457], -[13956, 1.00000, 0.60825, 0.31250], -[13957, 0.86729, 0.80763, 0.47363], -[13958, 0.70000, 0.95670, 0.50000], -[13959, 0.66335, 0.91033, 0.13044], -[13960, 0.69075, 0.95251, 0.35504], -[13961, 0.66298, 0.98153, 0.44873], -[13962, 0.97631, 0.50000, 0.05000], -[13963, 0.81758, 0.85547, 0.42611], -[13964, 0.67410, 0.86794, 0.05494], -[13965, 0.74245, 0.88507, 0.23310], -[13966, 0.51617, 0.96308, 0.03965], -[13967, 0.77517, 0.89511, 0.43837], -[13968, 0.55887, 0.97368, 0.11853], -[13969, 0.85286, 0.79281, 0.27626], -[13970, 0.94144, 0.62754, 0.14517], -[13971, 0.63173, 0.90291, 0.06214], -[13972, 0.85000, 0.82679, 0.50000], -[13973, 0.97717, 0.65084, 0.33320], -[13974, 0.91781, 0.69572, 0.21719], -[13975, 0.74244, 0.83183, 0.09584], -[13976, 0.80716, 0.86442, 0.41139], -[13977, 1.00000, 0.58660, 0.25000], -[13978, 0.83903, 0.70853, 0.05206], -[13979, 1.00000, 0.62990, 0.40000], -[13980, 0.63194, 1.00000, 0.41250], -[13981, 0.77661, 0.88411, 0.35050], -[13982, 0.95436, 0.53349, 0.03989], -[13983, 0.98233, 0.64887, 0.35419], -[13984, 0.52906, 0.94673, 0.01929], -[13985, 0.93738, 0.71243, 0.35459], -[13986, 0.85902, 0.74821, 0.16874], -[13987, 0.47631, 1.00000, 0.07500], -[13988, 0.85970, 0.76147, 0.20225], -[13989, 0.86720, 0.79901, 0.36919], -[13990, 0.92849, 0.61401, 0.08954], -[13991, 0.60825, 0.88750, 0.00000], -[13992, 0.72663, 0.80753, 0.02294], -[13993, 0.66917, 0.97651, 0.42005], -[13994, 0.59207, 0.95928, 0.12983], -[13995, 0.71999, 0.87152, 0.13956], -[13996, 0.97214, 0.60203, 0.18295], -[13997, 0.78493, 0.88460, 0.40289], -[13998, 0.76840, 0.86764, 0.24529], -[13999, 0.81848, 0.74670, 0.07494], -[14000, 0.68858, 0.88531, 0.11231], -[14001, 0.94791, 0.71371, 0.47985], -[14002, 0.98549, 0.66088, 0.47866], -[14003, 0.68012, 0.85386, 0.03431], -[14004, 0.90807, 0.62176, 0.05576], -[14005, 0.61263, 0.90190, 0.03112], -[14006, 0.47779, 0.96458, 0.00000], -[14007, 0.96458, 0.47779, 0.00000], -[14008, 0.95418, 0.68328, 0.32243], -[14009, 0.70855, 0.91490, 0.23574], -[14010, 0.61871, 0.92792, 0.09364], -[14011, 0.78357, 0.85466, 0.24592], -[14012, 0.85144, 0.81938, 0.38708], -[14013, 0.75288, 0.88810, 0.26860], -[14014, 0.77424, 0.77403, 0.04116], -[14015, 0.93578, 0.72739, 0.43388], -[14016, 0.45670, 0.97500, 0.00000], -[14017, 0.97500, 0.45670, 0.00000], -[14018, 0.88261, 0.76051, 0.27223], -[14019, 0.86999, 0.78657, 0.31638], -[14020, 0.97747, 0.57881, 0.15522], -[14021, 0.97461, 0.66650, 0.37646], -[14022, 0.72742, 0.93791, 0.47649], -[14023, 0.92093, 0.74453, 0.41615], -[14024, 0.94039, 0.67944, 0.24791], -[14025, 0.67441, 0.89203, 0.10121], -[14026, 0.67703, 0.93910, 0.23667], -[14027, 0.60279, 0.97621, 0.19455], -[14028, 0.83926, 0.68893, 0.01967], -[14029, 0.90032, 0.76675, 0.39407], -[14030, 0.73877, 0.89661, 0.25488], -[14031, 0.93548, 0.65596, 0.17693], -[14032, 0.83758, 0.80374, 0.25030], -[14033, 0.72468, 0.91699, 0.29054], -[14034, 0.86806, 0.63750, 0.00000], -[14035, 1.00000, 0.40000, 0.00000], -[14036, 0.40000, 1.00000, 0.00000], -[14037, 1.00000, 0.50000, 0.10000], -[14038, 0.50000, 1.00000, 0.10000], -[14039, 0.95114, 0.69695, 0.36003], -[14040, 0.59266, 0.93524, 0.07081], -[14041, 0.80827, 0.84846, 0.30768], -[14042, 0.95670, 0.63874, 0.20492], -[14043, 0.78952, 0.82232, 0.16710], -[14044, 0.91886, 0.70440, 0.23541], -[14045, 0.52067, 0.97078, 0.05604], -[14046, 0.87016, 0.79987, 0.38283], -[14047, 0.71694, 0.91519, 0.25660], -[14048, 0.98195, 0.55717, 0.13101], -[14049, 0.81593, 0.84612, 0.32920], -[14050, 0.85833, 0.73647, 0.13704], -[14051, 0.98648, 0.53086, 0.10493], -[14052, 1.00000, 0.45670, 0.05000], -[14053, 0.82475, 0.84935, 0.40199], -[14054, 0.54534, 1.00000, 0.16250], -[14055, 0.92032, 0.71015, 0.25500], -[14056, 0.56699, 1.00000, 0.20000], -[14057, 0.93846, 0.55658, 0.02989], -[14058, 0.79722, 0.79443, 0.11940], -[14059, 0.89721, 0.77529, 0.42567], -[14060, 0.85827, 0.72840, 0.11999], -[14061, 0.70593, 0.93343, 0.29503], -[14062, 0.69096, 0.96083, 0.39360], -[14063, 0.78049, 0.78497, 0.06801], -[14064, 0.63194, 1.00000, 0.38750], -[14065, 0.83149, 0.84126, 0.38628], -[14066, 0.86865, 0.66650, 0.03819], -[14067, 0.77430, 0.85871, 0.22589], -[14068, 0.86938, 0.74676, 0.18601], -[14069, 0.86797, 0.69642, 0.08316], -[14070, 0.88620, 0.78948, 0.43995], -[14071, 0.66161, 0.86913, 0.03191], -[14072, 0.94178, 0.57306, 0.05615], -[14073, 0.62990, 0.87500, 0.00000], -[14074, 1.00000, 0.62990, 0.37500], -[14075, 0.89564, 0.75445, 0.29733], -[14076, 0.61029, 1.00000, 0.30000], -[14077, 0.87730, 0.78931, 0.35906], -[14078, 0.96227, 0.69328, 0.42286], -[14079, 0.71086, 0.95096, 0.44546], -[14080, 0.66320, 0.95358, 0.24791], -[14081, 0.97542, 0.61060, 0.20246], -[14082, 0.80379, 0.81443, 0.17833], -[14083, 0.55643, 0.94887, 0.04951], -[14084, 0.81299, 0.86713, 0.49134], -[14085, 0.95274, 0.70535, 0.41203], -[14086, 0.85044, 0.83000, 0.47140], -[14087, 0.80137, 0.84119, 0.24850], -[14088, 0.91250, 0.76184, 0.50000], -[14089, 0.72018, 0.92777, 0.31642], -[14090, 0.83146, 0.75279, 0.10618], -[14091, 0.43301, 1.00000, 0.02500], -[14092, 0.90734, 0.61187, 0.03567], -[14093, 0.86409, 0.78958, 0.29181], -[14094, 0.82202, 0.82860, 0.27373], -[14095, 0.70765, 0.91053, 0.21069], -[14096, 0.69428, 0.96436, 0.46099], -[14097, 0.67542, 0.88204, 0.07630], -[14098, 0.66022, 0.94998, 0.22543], -[14099, 0.57493, 0.98698, 0.16968], -[14100, 0.95260, 0.52100, 0.01526], -[14101, 0.80096, 0.83799, 0.23518], -[14102, 0.73168, 0.85002, 0.10482], -[14103, 0.75871, 0.81630, 0.08492], -[14104, 0.53163, 0.98932, 0.10885], -[14105, 0.65594, 0.89162, 0.06509], -[14106, 0.65897, 0.92516, 0.14742], -[14107, 0.91715, 0.75709, 0.48637], -[14108, 0.70282, 0.95667, 0.42613], -[14109, 0.93140, 0.71351, 0.30472], -[14110, 0.98580, 0.59021, 0.19242], -[14111, 0.85347, 0.76661, 0.18580], -[14112, 0.63900, 0.97703, 0.27216], -[14113, 0.52369, 1.00000, 0.12500], -[14114, 0.73667, 0.93106, 0.42703], -[14115, 0.93005, 0.59508, 0.05745], -[14116, 0.73816, 0.78750, 0.00000], -[14117, 0.74946, 0.92303, 0.46298], -[14118, 0.87375, 0.73224, 0.16021], -[14119, 0.81711, 0.80356, 0.18109], -[14120, 0.88387, 0.69826, 0.11749], -[14121, 1.00000, 0.60825, 0.28750], -[14122, 0.85228, 0.79334, 0.25610], -[14123, 0.78750, 0.89175, 0.50000], -[14124, 0.58864, 1.00000, 0.23750], -[14125, 0.94688, 0.60125, 0.10333], -[14126, 0.93473, 0.72754, 0.38763], -[14127, 0.98533, 0.66289, 0.42623], -[14128, 0.68808, 0.92973, 0.22085], -[14129, 0.96241, 0.51596, 0.02742], -[14130, 0.94247, 0.69139, 0.27749], -[14131, 0.88625, 0.64401, 0.03564], -[14132, 0.86020, 0.81985, 0.43883], -[14133, 0.91190, 0.76331, 0.45874], -[14134, 0.75643, 0.88291, 0.24660], -[14135, 0.93800, 0.67296, 0.21140], -[14136, 0.77760, 0.84149, 0.17868], -[14137, 0.71228, 0.92537, 0.27099], -[14138, 0.92435, 0.74688, 0.43797], -[14139, 0.59788, 0.91918, 0.03760], -[14140, 0.61791, 0.91252, 0.05085], -[14141, 0.73139, 0.82400, 0.05017], -[14142, 0.70139, 0.89822, 0.15713], -[14143, 0.92363, 0.67150, 0.16487], -[14144, 0.88795, 0.78031, 0.36180], -[14145, 0.78838, 0.75128, 0.01965], -[14146, 1.00000, 0.56495, 0.18750], -[14147, 0.88096, 0.77443, 0.29748], -[14148, 0.95394, 0.65145, 0.21282], -[14149, 0.94839, 0.58905, 0.08702], -[14150, 0.75778, 0.90839, 0.36731], -[14151, 0.72636, 0.93424, 0.37109], -[14152, 0.89829, 0.73790, 0.24374], -[14153, 0.85868, 0.67645, 0.02861], -[14154, 0.69897, 0.84139, 0.03023], -[14155, 0.67895, 0.93052, 0.19942], -[14156, 0.87850, 0.78864, 0.34631], -[14157, 0.70761, 0.85597, 0.07111], -[14158, 0.80758, 0.84358, 0.26852], -[14159, 0.78629, 0.80066, 0.10239], -[14160, 0.58587, 0.95689, 0.10183], -[14161, 0.97919, 0.55239, 0.10816], -[14162, 0.66194, 0.97646, 0.33894], -[14163, 0.72835, 0.84443, 0.08279], -[14164, 0.83242, 0.77713, 0.15244], -[14165, 0.51624, 0.98256, 0.06904], -[14166, 0.97786, 0.64545, 0.28818], -[14167, 1.00000, 0.54330, 0.15000], -[14168, 0.68333, 0.96103, 0.33505], -[14169, 0.90212, 0.75878, 0.33212], -[14170, 0.86794, 0.81141, 0.42136], -[14171, 0.83665, 0.79627, 0.21033], -[14172, 0.93294, 0.69544, 0.24690], -[14173, 0.55158, 0.93713, 0.01457], -[14174, 0.73750, 0.93505, 0.50000], -[14175, 0.63194, 1.00000, 0.36250], -[14176, 0.80692, 0.87358, 0.43679], -[14177, 0.66138, 0.94484, 0.20307], -[14178, 0.73754, 0.88517, 0.19849], -[14179, 0.65155, 0.86250, 0.00000], -[14180, 0.82714, 0.84578, 0.36184], -[14181, 0.68776, 0.95438, 0.31352], -[14182, 0.78802, 0.84135, 0.20002], -[14183, 0.98232, 0.61261, 0.21950], -[14184, 0.75894, 0.89372, 0.28972], -[14185, 0.71315, 0.84047, 0.04827], -[14186, 0.74805, 0.86587, 0.16867], -[14187, 0.62215, 0.99230, 0.28208], -[14188, 0.81985, 0.86275, 0.44777], -[14189, 1.00000, 0.62990, 0.35000], -[14190, 0.83913, 0.81404, 0.27086], -[14191, 0.84036, 0.82983, 0.34331], -[14192, 0.77361, 0.88229, 0.29387], -[14193, 0.88534, 0.79296, 0.41729], -[14194, 0.85851, 0.69805, 0.05822], -[14195, 0.71961, 0.84378, 0.06448], -[14196, 0.52980, 0.98423, 0.08750], -[14197, 1.00000, 0.58660, 0.22500], -[14198, 0.73744, 0.93474, 0.45328], -[14199, 0.80261, 0.75166, 0.04103], -[14200, 0.78043, 0.86696, 0.25671], -[14201, 0.93526, 0.70601, 0.28374], -[14202, 0.77812, 0.90231, 0.47845], -[14203, 1.00000, 0.47835, 0.06250], -[14204, 0.96178, 0.67536, 0.30226], -[14205, 0.75503, 0.91019, 0.35263], -[14206, 0.65271, 0.91921, 0.11367], -[14207, 0.93526, 0.68820, 0.23175], -[14208, 0.71534, 0.93965, 0.33952], -[14209, 0.74331, 0.90461, 0.27730], -[14210, 0.84571, 0.78267, 0.19560], -[14211, 0.64842, 0.96961, 0.25512], -[14212, 0.80311, 0.72500, 0.00000], -[14213, 0.69689, 0.88921, 0.11988], -[14214, 0.92381, 0.63276, 0.09108], -[14215, 0.66307, 0.98578, 0.40169], -[14216, 0.90448, 0.71797, 0.20413], -[14217, 0.83750, 0.84845, 0.50000], -[14218, 0.95838, 0.70731, 0.44841], -[14219, 0.78703, 0.86690, 0.27527], -[14220, 0.62754, 0.98557, 0.26268], -[14221, 0.86150, 0.81890, 0.40653], -[14222, 0.85848, 0.80498, 0.30891], -[14223, 0.88506, 0.71718, 0.14788], -[14224, 0.80249, 0.87192, 0.36765], -[14225, 0.45389, 1.00000, 0.03542], -[14226, 0.82998, 0.81220, 0.22914], -[14227, 0.50000, 0.97779, 0.03542], -[14228, 0.84641, 0.67500, 0.00000], -[14229, 0.92249, 0.59487, 0.03382], -[14230, 0.97726, 0.57892, 0.13667], -[14231, 0.63356, 0.97602, 0.23884], -[14232, 1.00000, 0.52165, 0.11250], -[14233, 0.92830, 0.64163, 0.11411], -[14234, 0.85881, 0.72451, 0.10014], -[14235, 1.00000, 0.65000, 0.50000], -[14236, 0.65000, 1.00000, 0.50000], -[14237, 0.68473, 0.84666, 0.01300], -[14238, 0.92258, 0.73210, 0.31077], -[14239, 0.93301, 0.55000, 0.00000], -[14240, 0.87986, 0.71362, 0.12633], -[14241, 0.64110, 0.94493, 0.15482], -[14242, 0.61029, 1.00000, 0.27500], -[14243, 0.97263, 0.52163, 0.04719], -[14244, 0.83741, 0.72868, 0.06295], -[14245, 0.75173, 0.87230, 0.18807], -[14246, 0.91903, 0.75347, 0.39509], -[14247, 0.69734, 0.91684, 0.18942], -[14248, 0.90973, 0.69724, 0.16893], -[14249, 0.95127, 0.70164, 0.33820], -[14250, 0.65504, 0.87060, 0.01371], -[14251, 0.88585, 0.79231, 0.39434], -[14252, 0.96470, 0.60696, 0.14695], -[14253, 0.82006, 0.86626, 0.47047], -[14254, 0.78852, 0.88680, 0.37482], -[14255, 0.78627, 0.81436, 0.12257], -[14256, 0.90000, 0.78349, 0.50000], -[14257, 0.92562, 0.74144, 0.36741], -[14258, 0.96434, 0.70226, 0.46822], -[14259, 0.74743, 0.80856, 0.03986], -[14260, 0.67206, 0.95877, 0.26917], -[14261, 0.97908, 0.54327, 0.08709], -[14262, 0.83469, 0.76856, 0.13004], -[14263, 0.79905, 0.86735, 0.31694], -[14264, 0.64039, 0.98827, 0.30616], -[14265, 0.92594, 0.71864, 0.27489], -[14266, 0.84925, 0.83538, 0.42595], -[14267, 0.97466, 0.53509, 0.06609], -[14268, 0.62065, 0.97994, 0.21867], -[14269, 0.83612, 0.84959, 0.43833], -[14270, 0.96889, 0.63891, 0.22115], -[14271, 0.67799, 0.97160, 0.35473], -[14272, 0.74899, 0.85114, 0.12667], -[14273, 0.57843, 0.92833, 0.02198], -[14274, 0.87942, 0.70325, 0.10366], -[14275, 0.82989, 0.75540, 0.09284], -[14276, 0.63712, 0.88750, 0.01875], -[14277, 0.64424, 0.96011, 0.20244], -[14278, 0.83615, 0.79359, 0.18918], -[14279, 0.98063, 0.62837, 0.23720], -[14280, 0.89339, 0.72807, 0.18784], -[14281, 0.67321, 0.85000, 0.00000], -[14282, 0.91136, 0.58750, 0.00000], -[14283, 0.59501, 0.98318, 0.17586], -[14284, 0.63194, 1.00000, 0.33750], -[14285, 0.71050, 0.94936, 0.35965], -[14286, 0.77058, 0.83093, 0.12373], -[14287, 0.62485, 0.95665, 0.15321], -[14288, 1.00000, 0.65155, 0.46250], -[14289, 0.91465, 0.76508, 0.43602], -[14290, 0.76193, 0.85274, 0.15593], -[14291, 0.83664, 0.82621, 0.29128], -[14292, 0.66663, 0.93833, 0.18169], -[14293, 0.74455, 0.86404, 0.14605], -[14294, 0.77154, 0.89158, 0.30978], -[14295, 1.00000, 0.60825, 0.26250], -[14296, 0.94610, 0.59055, 0.07273], -[14297, 0.89922, 0.78532, 0.46191], -[14298, 0.80613, 0.82778, 0.19707], -[14299, 0.91268, 0.76578, 0.41340], -[14300, 0.76270, 0.79263, 0.03420], -[14301, 0.94889, 0.64106, 0.15996], -[14302, 0.93654, 0.65593, 0.15399], -[14303, 0.56699, 1.00000, 0.17500], -[14304, 0.57535, 0.97071, 0.10784], -[14305, 0.93465, 0.67574, 0.18857], -[14306, 1.00000, 0.62990, 0.32500], -[14307, 0.65359, 1.00000, 0.47500], -[14308, 0.75981, 0.77500, 0.00000], -[14309, 0.96790, 0.59108, 0.12338], -[14310, 0.81105, 0.87028, 0.38587], -[14311, 0.69924, 0.88465, 0.10407], -[14312, 0.87987, 0.64782, 0.01577], -[14313, 0.91068, 0.75140, 0.31441], -[14314, 1.00000, 0.65155, 0.43750], -[14315, 0.75247, 0.84403, 0.11251], -[14316, 0.66578, 0.90114, 0.08352], -[14317, 0.54534, 1.00000, 0.13750], -[14318, 0.97631, 0.50000, 0.02500], -[14319, 0.79434, 0.82088, 0.14771], -[14320, 0.94827, 0.70536, 0.32025], -[14321, 0.85195, 0.82089, 0.32848], -[14322, 0.62713, 0.92535, 0.07624], -[14323, 0.58864, 1.00000, 0.21250], -[14324, 0.91678, 0.67067, 0.12730], -[14325, 0.90531, 0.76568, 0.34698], -[14326, 0.47631, 1.00000, 0.05000], -[14327, 0.77679, 0.83766, 0.14703], -[14328, 0.65359, 1.00000, 0.45000], -[14329, 0.58371, 0.97783, 0.13556], -[14330, 0.90719, 0.67042, 0.10335], -[14331, 0.68750, 0.97835, 0.50000], -[14332, 0.80182, 0.79057, 0.09758], -[14333, 0.92354, 0.58391, 0.01420], -[14334, 0.92023, 0.70633, 0.20991], -[14335, 0.97945, 0.67035, 0.35437], -[14336, 0.91993, 0.69788, 0.18906], -[14337, 0.82168, 0.80130, 0.16413], -[14338, 0.82292, 0.77197, 0.10385], -[14339, 0.96810, 0.55636, 0.07174], -[14340, 0.93171, 0.65314, 0.13189], -[14341, 0.86687, 0.80937, 0.34599], -[14342, 0.76259, 0.87956, 0.22546], -[14343, 0.96756, 0.57971, 0.10207], -[14344, 1.00000, 0.42500, 0.00000], -[14345, 0.42500, 1.00000, 0.00000], -[14346, 1.00000, 0.50000, 0.07500], -[14347, 0.50000, 1.00000, 0.07500], -[14348, 0.81725, 0.82504, 0.21340], -[14349, 0.70700, 0.94713, 0.31604], -[14350, 0.94256, 0.62282, 0.10699], -[14351, 0.61048, 0.96930, 0.15567], -[14352, 0.51738, 0.96088, 0.01021], -[14353, 0.95359, 0.67198, 0.23533], -[14354, 0.77279, 0.90987, 0.42299], -[14355, 0.67361, 0.90723, 0.10728], -[14356, 0.61162, 0.95499, 0.11925], -[14357, 0.60056, 0.91416, 0.01548], -[14358, 0.95840, 0.70574, 0.37939], -[14359, 0.74077, 0.93297, 0.38977], -[14360, 0.84968, 0.84213, 0.48229], -[14361, 0.90996, 0.65656, 0.08485], -[14362, 0.93766, 0.70535, 0.26603], -[14363, 0.76961, 0.90317, 0.34611], -[14364, 0.53093, 0.96379, 0.02990], -[14365, 0.60508, 0.96761, 0.14023], -[14366, 0.80011, 0.78120, 0.07411], -[14367, 0.55367, 0.98995, 0.11877], -[14368, 0.88913, 0.79001, 0.36874], -[14369, 0.55562, 0.97849, 0.09290], -[14370, 0.68482, 0.98095, 0.47375], -[14371, 0.96280, 0.57455, 0.08180], -[14372, 0.96942, 0.63240, 0.19611], -[14373, 0.72385, 0.94611, 0.38612], -[14374, 0.97221, 0.68964, 0.39367], -[14375, 0.88139, 0.77044, 0.25157], -[14376, 1.00000, 0.65155, 0.41250], -[14377, 0.88338, 0.75495, 0.21385], -[14378, 0.88971, 0.62500, 0.00000], -[14379, 0.83211, 0.83874, 0.30860], -[14380, 0.91374, 0.60085, 0.01356], -[14381, 0.63207, 0.94378, 0.12261], -[14382, 0.67361, 0.98250, 0.38330], -[14383, 0.94007, 0.73943, 0.45296], -[14384, 0.98125, 0.66599, 0.33750], -[14385, 0.65359, 1.00000, 0.42500], -[14386, 1.00000, 0.56495, 0.16250], -[14387, 0.53861, 0.97767, 0.06733], -[14388, 0.85718, 0.80422, 0.27251], -[14389, 0.91723, 0.72169, 0.23326], -[14390, 0.83444, 0.82174, 0.25124], -[14391, 0.88617, 0.69045, 0.08593], -[14392, 0.98472, 0.67857, 0.44171], -[14393, 0.87897, 0.78168, 0.27638], -[14394, 0.79610, 0.87853, 0.33239], -[14395, 0.96764, 0.68842, 0.34688], -[14396, 0.74546, 0.93676, 0.47688], -[14397, 0.90048, 0.65168, 0.05470], -[14398, 0.72268, 0.85808, 0.08122], -[14399, 1.00000, 0.58660, 0.20000], -[14400, 0.93510, 0.74795, 0.48181], -[14401, 0.76813, 0.91686, 0.44062], -[14402, 1.00000, 0.45670, 0.02500], -[14403, 0.69976, 0.85885, 0.04512], -[14404, 0.69486, 0.83750, 0.00000], -[14405, 0.52369, 1.00000, 0.10000], -[14406, 0.89784, 0.70349, 0.13494], -[14407, 0.74418, 0.93364, 0.40565], -[14408, 0.77569, 0.90476, 0.38114], -[14409, 0.65637, 0.94298, 0.16167], -[14410, 0.63194, 1.00000, 0.31250], -[14411, 0.86187, 0.80467, 0.28969], -[14412, 0.95007, 0.54432, 0.01433], -[14413, 0.75736, 0.92473, 0.42193], -[14414, 0.73050, 0.93729, 0.34936], -[14415, 0.97631, 0.69235, 0.45131], -[14416, 0.80044, 0.86647, 0.29158], -[14417, 0.77500, 0.91340, 0.50000], -[14418, 0.61029, 1.00000, 0.25000], -[14419, 0.97125, 0.66690, 0.28352], -[14420, 0.79665, 0.89316, 0.44624], -[14421, 0.77392, 0.90922, 0.40161], -[14422, 0.79484, 0.77396, 0.04768], -[14423, 0.71245, 0.90685, 0.17531], -[14424, 0.69421, 0.91782, 0.16669], -[14425, 0.83775, 0.85235, 0.41559], -[14426, 0.77549, 0.80696, 0.07234], -[14427, 0.65889, 0.97662, 0.28178], -[14428, 0.63463, 0.90479, 0.03718], -[14429, 0.97956, 0.66172, 0.30429], -[14430, 0.76238, 0.90693, 0.32117], -[14431, 1.00000, 0.54330, 0.12500], -[14432, 0.75946, 0.91994, 0.38694], -[14433, 0.88750, 0.80514, 0.50000], -[14434, 0.87695, 0.81100, 0.40405], -[14435, 0.70351, 0.96992, 0.48127], -[14436, 0.70436, 0.95473, 0.33149], -[14437, 0.81910, 0.83316, 0.23352], -[14438, 0.97500, 0.69689, 0.50000], -[14439, 0.70066, 0.95081, 0.29666], -[14440, 0.95152, 0.66070, 0.19266], -[14441, 0.67530, 0.97328, 0.31736], -[14442, 1.00000, 0.62990, 0.30000], -[14443, 0.98891, 0.67634, 0.46215], -[14444, 0.89723, 0.68969, 0.10486], -[14445, 0.77101, 0.80041, 0.05079], -[14446, 0.78196, 0.90757, 0.45643], -[14447, 0.91434, 0.76526, 0.37594], -[14448, 0.67578, 0.93071, 0.16205], -[14449, 1.00000, 0.65155, 0.38750], -[14450, 0.65359, 1.00000, 0.40000], -[14451, 0.77446, 0.88283, 0.25904], -[14452, 0.68941, 0.90731, 0.12742], -[14453, 0.76400, 0.92372, 0.48053], -[14454, 0.79374, 0.89525, 0.42276], -[14455, 0.91619, 0.74518, 0.29300], -[14456, 0.72331, 0.83159, 0.02781], -[14457, 0.82500, 0.87010, 0.50000], -[14458, 0.95005, 0.63901, 0.14391], -[14459, 0.82476, 0.71250, 0.00000], -[14460, 0.63807, 0.96379, 0.18063], -[14461, 0.96331, 0.67359, 0.26251], -[14462, 0.63765, 0.93491, 0.10304], -[14463, 0.85732, 0.78687, 0.21005], -[14464, 0.98280, 0.68698, 0.47866], -[14465, 0.65306, 0.91886, 0.09071], -[14466, 0.82616, 0.74367, 0.04968], -[14467, 0.54416, 0.96814, 0.04719], -[14468, 0.71484, 0.87498, 0.09759], -[14469, 0.75889, 0.81910, 0.06213], -[14470, 0.73682, 0.90648, 0.22798], -[14471, 0.88366, 0.74413, 0.17732], -[14472, 0.64510, 0.93992, 0.12704], -[14473, 1.00000, 0.60825, 0.23750], -[14474, 0.64241, 0.98958, 0.28335], -[14475, 0.97279, 0.61735, 0.16613], -[14476, 0.85854, 0.75300, 0.13249], -[14477, 0.69629, 0.87836, 0.07220], -[14478, 0.89153, 0.75807, 0.23509], -[14479, 0.68596, 0.98325, 0.45093], -[14480, 0.66879, 0.88710, 0.04661], -[14481, 0.73323, 0.89212, 0.17394], -[14482, 0.90617, 0.78463, 0.44450], -[14483, 0.56590, 0.94614, 0.02622], -[14484, 0.57467, 0.96839, 0.08542], -[14485, 0.92590, 0.74418, 0.33001], -[14486, 0.85503, 0.84044, 0.44759], -[14487, 0.75439, 0.91080, 0.29627], -[14488, 0.91291, 0.77859, 0.47602], -[14489, 0.88922, 0.80523, 0.46725], -[14490, 0.98335, 0.60191, 0.16672], -[14491, 0.90098, 0.77064, 0.31365], -[14492, 0.89914, 0.75682, 0.25672], -[14493, 0.90101, 0.74229, 0.22136], -[14494, 0.93386, 0.69391, 0.20513], -[14495, 0.76222, 0.87828, 0.20257], -[14496, 0.62196, 0.94594, 0.10096], -[14497, 0.72500, 0.95670, 0.50000], -[14498, 0.90587, 0.71800, 0.17630], -[14499, 0.68065, 0.94693, 0.21539], -[14500, 0.87559, 0.82001, 0.45616], -[14501, 0.69403, 0.95287, 0.27326], -[14502, 0.87530, 0.75141, 0.16787], -[14503, 0.55084, 0.95605, 0.02694], -[14504, 0.81966, 0.78971, 0.11807], -[14505, 0.90568, 0.77515, 0.35711], -[14506, 0.69095, 0.94550, 0.23503], -[14507, 0.77958, 0.81815, 0.09431], -[14508, 0.85717, 0.69130, 0.02135], -[14509, 0.59885, 0.93767, 0.04844], -[14510, 0.91454, 0.74007, 0.25982], -[14511, 0.80565, 0.87717, 0.34734], -[14512, 0.73595, 0.91562, 0.25115], -[14513, 0.62757, 0.97751, 0.19577], -[14514, 0.97992, 0.65372, 0.26686], -[14515, 0.94403, 0.73013, 0.36680], -[14516, 0.85381, 0.83302, 0.36164], -[14517, 0.64954, 0.89361, 0.02924], -[14518, 0.89665, 0.78336, 0.34365], -[14519, 0.78146, 0.76250, 0.00000], -[14520, 0.86972, 0.79626, 0.27260], -[14521, 0.97548, 0.68800, 0.36844], -[14522, 1.00000, 0.52165, 0.08750], -[14523, 0.74251, 0.83733, 0.06414], -[14524, 0.86806, 0.66250, 0.00000], -[14525, 0.70543, 0.93940, 0.25020], -[14526, 0.68416, 0.98242, 0.40369], -[14527, 0.94584, 0.63538, 0.12017], -[14528, 0.87979, 0.68988, 0.06106], -[14529, 0.86983, 0.68905, 0.04038], -[14530, 0.74937, 0.89390, 0.21345], -[14531, 0.74930, 0.92954, 0.36873], -[14532, 0.65359, 1.00000, 0.37500], -[14533, 0.68532, 0.95527, 0.25383], -[14534, 0.92623, 0.76416, 0.46817], -[14535, 0.90376, 0.78577, 0.40647], -[14536, 0.52183, 0.95951, 0.00000], -[14537, 0.73410, 0.94882, 0.43777], -[14538, 0.83433, 0.86413, 0.48225], -[14539, 0.88509, 0.67230, 0.04409], -[14540, 0.89908, 0.67410, 0.07499], -[14541, 0.92739, 0.61415, 0.04595], -[14542, 1.00000, 0.65155, 0.36250], -[14543, 0.78142, 0.84852, 0.16400], -[14544, 0.97189, 0.54442, 0.04993], -[14545, 0.73093, 0.94978, 0.41515], -[14546, 0.82093, 0.86514, 0.35424], -[14547, 0.67604, 0.86763, 0.01640], -[14548, 0.79630, 0.86781, 0.26189], -[14549, 0.79481, 0.79773, 0.08064], -[14550, 0.72913, 0.95432, 0.46004], -[14551, 0.56699, 1.00000, 0.15000], -[14552, 0.71651, 0.82500, 0.00000], -[14553, 0.66148, 0.98286, 0.29886], -[14554, 0.76440, 0.90580, 0.30177], -[14555, 0.84607, 0.78385, 0.16261], -[14556, 1.00000, 0.47779, 0.03542], -[14557, 0.91981, 0.68888, 0.14856], -[14558, 0.58864, 1.00000, 0.18750], -[14559, 0.76876, 0.86355, 0.17210], -[14560, 0.92875, 0.63131, 0.07201], -[14561, 0.79875, 0.85630, 0.22963], -[14562, 0.72297, 0.95985, 0.48074], -[14563, 0.63194, 1.00000, 0.28750], -[14564, 0.81219, 0.80608, 0.13234], -[14565, 0.83017, 0.81452, 0.19649], -[14566, 0.66813, 0.98799, 0.35085], -[14567, 0.90555, 0.62668, 0.01831], -[14568, 0.76699, 0.92475, 0.46190], -[14569, 0.61616, 0.93408, 0.06089], -[14570, 0.51225, 0.98578, 0.04077], -[14571, 0.93770, 0.58188, 0.02333], -[14572, 0.80670, 0.84353, 0.21226], -[14573, 0.58420, 0.95567, 0.06346], -[14574, 0.75388, 0.93463, 0.44179], -[14575, 0.93768, 0.73701, 0.34838], -[14576, 0.98397, 0.57381, 0.11531], -[14577, 0.86891, 0.67494, 0.01509], -[14578, 0.96359, 0.62882, 0.15071], -[14579, 0.73303, 0.93212, 0.30060], -[14580, 0.79421, 0.76812, 0.02548], -[14581, 0.85173, 0.74553, 0.09419], -[14582, 0.98040, 0.59655, 0.14084], -[14583, 0.65760, 0.97107, 0.23412], -[14584, 0.59761, 0.98405, 0.15267], -[14585, 0.61559, 0.94449, 0.08144], -[14586, 0.88011, 0.73932, 0.14636], -[14587, 0.59430, 0.97261, 0.11629], -[14588, 0.64993, 0.94549, 0.13929], -[14589, 0.69357, 0.97966, 0.42446], -[14590, 0.95389, 0.53542, 0.00000], -[14591, 0.86279, 0.77089, 0.17150], -[14592, 0.84816, 0.84471, 0.38300], -[14593, 0.84011, 0.74830, 0.07458], -[14594, 0.82524, 0.85009, 0.29229], -[14595, 0.74038, 0.87137, 0.12664], -[14596, 0.81858, 0.77815, 0.08607], -[14597, 0.83249, 0.82108, 0.21763], -[14598, 0.74906, 0.80781, 0.01697], -[14599, 0.86908, 0.78753, 0.23269], -[14600, 0.68004, 0.92398, 0.13835], -[14601, 0.89534, 0.72971, 0.16395], -[14602, 0.90000, 0.79793, 0.48125], -[14603, 0.85581, 0.73164, 0.07637], -[14604, 0.85439, 0.82429, 0.30572], -[14605, 1.00000, 0.62990, 0.27500], -[14606, 0.71723, 0.96514, 0.46093], -[14607, 0.84014, 0.72813, 0.04016], -[14608, 0.77665, 0.78329, 0.01962], -[14609, 0.54534, 1.00000, 0.11250], -[14610, 0.90325, 0.78530, 0.37757], -[14611, 0.93191, 0.67183, 0.14251], -[14612, 0.82741, 0.73530, 0.02846], -[14613, 0.75224, 0.83895, 0.07814], -[14614, 0.79857, 0.89964, 0.47346], -[14615, 0.89520, 0.77606, 0.28957], -[14616, 0.76503, 0.83590, 0.09509], -[14617, 0.83886, 0.84591, 0.33055], -[14618, 0.95310, 0.73013, 0.41905], -[14619, 0.56495, 0.93750, 0.00000], -[14620, 0.61029, 1.00000, 0.22500], -[14621, 0.79930, 0.84079, 0.18003], -[14622, 0.96458, 0.71962, 0.50000], -[14623, 0.95382, 0.69305, 0.25879], -[14624, 0.81624, 0.86825, 0.33198], -[14625, 0.87505, 0.80740, 0.32463], -[14626, 0.69612, 0.90186, 0.11213], -[14627, 0.97664, 0.67969, 0.31923], -[14628, 0.71120, 0.96412, 0.38524], -[14629, 0.82459, 0.87225, 0.41091], -[14630, 0.89085, 0.80747, 0.44445], -[14631, 0.85672, 0.70767, 0.03745], -[14632, 0.95896, 0.62591, 0.12912], -[14633, 0.86908, 0.82395, 0.37859], -[14634, 0.70540, 0.97377, 0.44324], -[14635, 0.95143, 0.57411, 0.03707], -[14636, 0.95836, 0.69215, 0.27266], -[14637, 0.87500, 0.82679, 0.50000], -[14638, 0.70437, 0.97172, 0.40581], -[14639, 0.81486, 0.76733, 0.05677], -[14640, 0.90691, 0.75998, 0.27810], -[14641, 0.78933, 0.88132, 0.27710], -[14642, 0.87200, 0.71154, 0.07236], -[14643, 0.58271, 0.95179, 0.04821], -[14644, 0.65359, 1.00000, 0.35000], -[14645, 0.95722, 0.72952, 0.46458], -[14646, 1.00000, 0.58660, 0.17500], -[14647, 0.96117, 0.55394, 0.03199], -[14648, 0.86641, 0.77633, 0.18937], -[14649, 0.85492, 0.77283, 0.15090], -[14650, 0.98459, 0.61664, 0.18308], -[14651, 0.92930, 0.69163, 0.17110], -[14652, 0.78112, 0.90557, 0.35885], -[14653, 0.59732, 0.95845, 0.08199], -[14654, 0.69925, 0.91453, 0.14664], -[14655, 0.93651, 0.72820, 0.29293], -[14656, 0.82348, 0.84450, 0.25723], -[14657, 0.75341, 0.92557, 0.33865], -[14658, 0.95000, 0.74019, 0.50000], -[14659, 0.97144, 0.53516, 0.03058], -[14660, 1.00000, 0.56495, 0.13750], -[14661, 0.94150, 0.61405, 0.06745], -[14662, 0.50000, 0.97500, 0.00000], -[14663, 0.97500, 0.50000, 0.00000], -[14664, 0.83107, 0.86285, 0.37510], -[14665, 0.95974, 0.60210, 0.09101], -[14666, 0.78123, 0.90038, 0.32703], -[14667, 0.93496, 0.71465, 0.24299], -[14668, 1.00000, 0.65155, 0.33750], -[14669, 0.93301, 0.57500, 0.00000], -[14670, 0.65482, 0.91434, 0.06826], -[14671, 0.79350, 0.88473, 0.30265], -[14672, 0.85974, 0.83803, 0.39950], -[14673, 0.95731, 0.72937, 0.44161], -[14674, 0.97132, 0.66077, 0.23209], -[14675, 0.68445, 0.87634, 0.03586], -[14676, 0.70016, 0.97193, 0.36963], -[14677, 0.77197, 0.89743, 0.27484], -[14678, 0.66401, 0.93460, 0.12883], -[14679, 0.85295, 0.78981, 0.18228], -[14680, 0.47631, 1.00000, 0.02500], -[14681, 1.00000, 0.45000, 0.00000], -[14682, 0.45000, 1.00000, 0.00000], -[14683, 1.00000, 0.50000, 0.05000], -[14684, 0.50000, 1.00000, 0.05000], -[14685, 0.85802, 0.80650, 0.24333], -[14686, 0.89149, 0.79146, 0.32279], -[14687, 0.73118, 0.82177, 0.00737], -[14688, 0.68339, 0.88781, 0.05573], -[14689, 0.60825, 0.91250, 0.00000], -[14690, 1.00000, 0.60825, 0.21250], -[14691, 0.92630, 0.75618, 0.34881], -[14692, 0.85793, 0.72091, 0.05617], -[14693, 0.78908, 0.87339, 0.24054], -[14694, 0.62835, 0.90721, 0.01522], -[14695, 0.96526, 0.71806, 0.42533], -[14696, 0.94676, 0.73971, 0.40295], -[14697, 0.84164, 0.82069, 0.23339], -[14698, 0.87876, 0.76402, 0.18838], -[14699, 0.91206, 0.68832, 0.11603], -[14700, 0.82831, 0.87486, 0.45883], -[14701, 0.92061, 0.64281, 0.06128], -[14702, 0.96541, 0.69122, 0.29101], -[14703, 0.98125, 0.64434, 0.22500], -[14704, 0.86448, 0.82597, 0.34446], -[14705, 1.00000, 0.67321, 0.47500], -[14706, 0.87946, 0.77469, 0.21674], -[14707, 0.87501, 0.71954, 0.08712], -[14708, 0.95192, 0.71216, 0.29862], -[14709, 0.59148, 0.94006, 0.03052], -[14710, 0.71980, 0.91781, 0.19410], -[14711, 0.62775, 0.96371, 0.13765], -[14712, 0.68940, 0.93609, 0.17974], -[14713, 0.91661, 0.63258, 0.03751], -[14714, 0.81392, 0.88658, 0.42300], -[14715, 0.71257, 0.94633, 0.27386], -[14716, 0.86693, 0.74292, 0.11121], -[14717, 0.85197, 0.76033, 0.11174], -[14718, 0.95243, 0.70681, 0.28083], -[14719, 0.52369, 1.00000, 0.07500], -[14720, 0.98052, 0.56823, 0.08699], -[14721, 0.85592, 0.80331, 0.22243], -[14722, 0.72967, 0.85524, 0.06278], -[14723, 0.73816, 0.81250, 0.00000], -[14724, 0.72519, 0.92378, 0.22471], -[14725, 0.65537, 0.90573, 0.04698], -[14726, 1.00000, 0.54330, 0.10000], -[14727, 0.62392, 0.92016, 0.03173], -[14728, 0.81306, 0.86091, 0.26962], -[14729, 0.81250, 0.89175, 0.50000], -[14730, 0.74492, 0.92466, 0.28667], -[14731, 1.00000, 0.67500, 0.50000], -[14732, 0.67500, 1.00000, 0.50000], -[14733, 0.77396, 0.88859, 0.24108], -[14734, 1.00000, 0.67321, 0.45000], -[14735, 0.76250, 0.93505, 0.50000], -[14736, 0.91136, 0.61250, 0.00000], -[14737, 0.63194, 1.00000, 0.26250], -[14738, 0.73667, 0.93981, 0.32691], -[14739, 0.66010, 0.95996, 0.18584], -[14740, 0.96613, 0.69704, 0.30846], -[14741, 0.78261, 0.87274, 0.21398], -[14742, 0.74455, 0.92023, 0.26591], -[14743, 0.88047, 0.72556, 0.10698], -[14744, 0.94367, 0.62616, 0.08309], -[14745, 0.84641, 0.70000, 0.00000], -[14746, 0.83252, 0.76257, 0.07359], -[14747, 0.92393, 0.74289, 0.27411], -[14748, 0.67853, 0.96169, 0.23285], -[14749, 0.75046, 0.83000, 0.04765], -[14750, 0.62990, 0.90000, 0.00000], -[14751, 0.64263, 0.98075, 0.21343], -[14752, 0.88485, 0.81218, 0.38003], -[14753, 0.95526, 0.69126, 0.24183], -[14754, 0.72295, 0.96448, 0.43512], -[14755, 0.75819, 0.90068, 0.23345], -[14756, 0.73794, 0.95520, 0.48623], -[14757, 0.68171, 0.91954, 0.11667], -[14758, 0.88083, 0.73646, 0.12716], -[14759, 0.75015, 0.85302, 0.09151], -[14760, 0.73433, 0.91070, 0.20219], -[14761, 0.82294, 0.82378, 0.18148], -[14762, 0.98125, 0.55052, 0.06250], -[14763, 0.67524, 1.00000, 0.46250], -[14764, 0.68612, 0.89863, 0.07680], -[14765, 0.80311, 0.75000, 0.00000], -[14766, 0.54672, 0.95322, 0.00000], -[14767, 0.52406, 0.97552, 0.01891], -[14768, 0.65359, 1.00000, 0.32500], -[14769, 0.89137, 0.66190, 0.02544], -[14770, 0.93015, 0.71715, 0.21988], -[14771, 0.98530, 0.51522, 0.02914], -[14772, 0.81742, 0.88842, 0.47484], -[14773, 0.70980, 0.93575, 0.21908], -[14774, 0.74232, 0.82714, 0.02737], -[14775, 0.81334, 0.82337, 0.15461], -[14776, 1.00000, 0.67321, 0.42500], -[14777, 0.91024, 0.71393, 0.15266], -[14778, 0.98287, 0.70177, 0.47956], -[14779, 0.76505, 0.90212, 0.25515], -[14780, 0.97185, 0.63806, 0.17203], -[14781, 0.72483, 0.96153, 0.40354], -[14782, 1.00000, 0.62990, 0.25000], -[14783, 0.93750, 0.76184, 0.50000], -[14784, 0.95416, 0.72222, 0.33468], -[14785, 0.96842, 0.70206, 0.33075], -[14786, 0.69765, 0.86302, 0.02263], -[14787, 0.87257, 0.83111, 0.41423], -[14788, 0.83459, 0.87059, 0.42917], -[14789, 0.53218, 0.98442, 0.04475], -[14790, 0.94665, 0.74757, 0.43253], -[14791, 0.96200, 0.73068, 0.48280], -[14792, 1.00000, 0.65155, 0.31250], -[14793, 0.94576, 0.59590, 0.04156], -[14794, 0.67524, 1.00000, 0.43750], -[14795, 0.98930, 0.68961, 0.42459], -[14796, 0.90042, 0.74645, 0.19645], -[14797, 0.58686, 0.93049, 0.00000], -[14798, 0.82690, 0.86104, 0.31241], -[14799, 0.77854, 0.83947, 0.11332], -[14800, 0.58864, 1.00000, 0.16250], -[14801, 0.94269, 0.70525, 0.22708], -[14802, 0.71390, 0.90220, 0.12991], -[14803, 0.94397, 0.74505, 0.37938], -[14804, 0.79006, 0.91235, 0.43548], -[14805, 0.88596, 0.81021, 0.36073], -[14806, 0.92307, 0.67267, 0.10425], -[14807, 0.79519, 0.84431, 0.15893], -[14808, 0.63507, 0.97054, 0.15889], -[14809, 0.84124, 0.86211, 0.39579], -[14810, 0.68318, 0.98397, 0.33610], -[14811, 0.79409, 0.90568, 0.39486], -[14812, 0.88812, 0.79584, 0.30009], -[14813, 0.56699, 1.00000, 0.12500], -[14814, 0.96844, 0.61342, 0.11532], -[14815, 0.84384, 0.83539, 0.27149], -[14816, 0.95750, 0.72953, 0.38539], -[14817, 0.65155, 0.88750, 0.00000], -[14818, 0.89657, 0.72991, 0.14560], -[14819, 0.53969, 0.96489, 0.01010], -[14820, 0.88742, 0.80606, 0.34174], -[14821, 0.92118, 0.77634, 0.39486], -[14822, 0.94098, 0.74089, 0.33245], -[14823, 0.61029, 1.00000, 0.20000], -[14824, 0.93090, 0.77188, 0.48864], -[14825, 0.66888, 0.88802, 0.02404], -[14826, 0.72518, 0.95850, 0.36608], -[14827, 0.96799, 0.53566, 0.01140], -[14828, 0.87449, 0.80604, 0.28004], -[14829, 0.81265, 0.87556, 0.31051], -[14830, 0.73878, 0.94932, 0.37377], -[14831, 0.75551, 0.88659, 0.17417], -[14832, 0.91165, 0.76872, 0.29710], -[14833, 1.00000, 0.67321, 0.40000], -[14834, 0.69057, 0.97289, 0.30022], -[14835, 0.79032, 0.84115, 0.13779], -[14836, 0.93327, 0.65399, 0.09414], -[14837, 0.70241, 0.87621, 0.05017], -[14838, 1.00000, 0.52165, 0.06250], -[14839, 0.93262, 0.73056, 0.25493], -[14840, 0.67267, 0.97425, 0.25117], -[14841, 0.67524, 1.00000, 0.41250], -[14842, 0.89717, 0.77739, 0.26673], -[14843, 0.96432, 0.67137, 0.21175], -[14844, 0.86250, 0.84845, 0.50000], -[14845, 0.90902, 0.77937, 0.32637], -[14846, 0.78379, 0.89958, 0.29904], -[14847, 0.69875, 0.94183, 0.20221], -[14848, 0.91779, 0.78484, 0.42473], -[14849, 0.84020, 0.79035, 0.13476], -[14850, 0.73652, 0.84568, 0.04571], -[14851, 0.79773, 0.81337, 0.09245], -[14852, 0.88971, 0.65000, 0.00000], -[14853, 0.95263, 0.56712, 0.01523], -[14854, 0.73048, 0.93678, 0.26968], -[14855, 0.77605, 0.85483, 0.13762], -[14856, 0.88438, 0.82563, 0.47662], -[14857, 0.79859, 0.89857, 0.36128], -[14858, 0.61526, 0.98668, 0.16455], -[14859, 0.68058, 0.95254, 0.19312], -[14860, 0.94647, 0.73083, 0.31326], -[14861, 0.75041, 0.93022, 0.30928], -[14862, 0.71250, 0.97835, 0.50000], -[14863, 0.74457, 0.88931, 0.15417], -[14864, 0.92581, 0.61709, 0.02328], -[14865, 0.97509, 0.65469, 0.20670], -[14866, 0.79304, 0.90988, 0.40691], -[14867, 0.80239, 0.82613, 0.12698], -[14868, 0.81090, 0.80804, 0.10630], -[14869, 0.87699, 0.82273, 0.36041], -[14870, 0.56303, 0.98230, 0.07151], -[14871, 0.61107, 0.96508, 0.09905], -[14872, 0.93493, 0.76364, 0.40816], -[14873, 0.71746, 0.85498, 0.03101], -[14874, 0.90548, 0.64854, 0.02533], -[14875, 0.90261, 0.70968, 0.11571], -[14876, 0.93996, 0.65856, 0.11417], -[14877, 0.92161, 0.76748, 0.33353], -[14878, 0.87651, 0.82844, 0.39252], -[14879, 0.79273, 0.80169, 0.05812], -[14880, 0.86684, 0.81378, 0.27029], -[14881, 0.67410, 0.90481, 0.06023], -[14882, 0.85186, 0.82632, 0.25906], -[14883, 0.97295, 0.70744, 0.36040], -[14884, 1.00000, 0.58660, 0.15000], -[14885, 0.81381, 0.75760, 0.01977], -[14886, 0.95173, 0.66574, 0.15667], -[14887, 0.87130, 0.83856, 0.43150], -[14888, 0.97024, 0.56727, 0.04834], -[14889, 0.65359, 1.00000, 0.30000], -[14890, 0.79578, 0.89944, 0.34199], -[14891, 0.79074, 0.86282, 0.18771], -[14892, 0.84942, 0.86224, 0.45212], -[14893, 0.75981, 0.80000, 0.00000], -[14894, 0.96884, 0.68306, 0.25062], -[14895, 0.54534, 1.00000, 0.08750], -[14896, 0.56535, 0.96689, 0.03842], -[14897, 0.89920, 0.80631, 0.40568], -[14898, 0.98367, 0.50886, 0.00900], -[14899, 1.00000, 0.60825, 0.18750], -[14900, 0.70510, 0.98446, 0.46356], -[14901, 0.95461, 0.69023, 0.21680], -[14902, 0.86207, 0.79512, 0.19580], -[14903, 0.70169, 0.97553, 0.34535], -[14904, 0.94066, 0.76209, 0.44928], -[14905, 0.80623, 0.89694, 0.38282], -[14906, 0.63194, 1.00000, 0.23750], -[14907, 0.57270, 0.97119, 0.05583], -[14908, 0.71449, 0.89488, 0.10347], -[14909, 0.65237, 0.94479, 0.11224], -[14910, 0.92202, 0.78441, 0.44382], -[14911, 0.67524, 1.00000, 0.38750], -[14912, 0.67321, 0.87500, 0.00000], -[14913, 1.00000, 0.67321, 0.37500], -[14914, 0.90601, 0.73927, 0.18142], -[14915, 0.67116, 0.94435, 0.14416], -[14916, 0.81222, 0.89404, 0.40073], -[14917, 0.75250, 0.94689, 0.42246], -[14918, 0.77456, 0.82973, 0.07513], -[14919, 0.82757, 0.75707, 0.04063], -[14920, 0.81220, 0.83535, 0.16598], -[14921, 0.60817, 0.93048, 0.01672], -[14922, 1.00000, 0.56495, 0.11250], -[14923, 0.92500, 0.78349, 0.50000], -[14924, 0.72911, 0.91473, 0.18191], -[14925, 0.91720, 0.77732, 0.34486], -[14926, 0.84097, 0.78274, 0.11310], -[14927, 0.95702, 0.62952, 0.10315], -[14928, 1.00000, 0.65155, 0.28750], -[14929, 0.97623, 0.64928, 0.19158], -[14930, 0.80717, 0.87728, 0.27939], -[14931, 0.58268, 0.94563, 0.01401], -[14932, 0.98322, 0.61850, 0.15247], -[14933, 0.72662, 0.93753, 0.24876], -[14934, 0.77377, 0.92450, 0.36957], -[14935, 0.59223, 0.97721, 0.09405], -[14936, 0.69883, 0.97552, 0.32527], -[14937, 0.71740, 0.95940, 0.31163], -[14938, 0.73328, 0.89272, 0.13125], -[14939, 0.76012, 0.91800, 0.27607], -[14940, 0.69980, 0.98398, 0.38694], -[14941, 0.66875, 0.97055, 0.21405], -[14942, 0.90709, 0.79710, 0.38687], -[14943, 0.73331, 0.88307, 0.10819], -[14944, 0.81732, 0.89509, 0.45606], -[14945, 0.75163, 0.95099, 0.45717], -[14946, 0.96122, 0.72535, 0.35472], -[14947, 0.84735, 0.72238, 0.01898], -[14948, 0.94466, 0.72822, 0.27968], -[14949, 0.91979, 0.67304, 0.08499], -[14950, 0.84123, 0.81127, 0.17531], -[14951, 0.98125, 0.70207, 0.37500], -[14952, 0.93460, 0.74927, 0.30827], -[14953, 0.89410, 0.70942, 0.08887], -[14954, 0.84322, 0.86021, 0.35580], -[14955, 0.98284, 0.70837, 0.43628], -[14956, 0.91391, 0.75326, 0.23687], -[14957, 0.94862, 0.75574, 0.46987], -[14958, 0.98150, 0.70796, 0.41311], -[14959, 0.70723, 0.89360, 0.08354], -[14960, 0.72598, 0.91057, 0.15933], -[14961, 0.93683, 0.76767, 0.42734], -[14962, 0.83758, 0.86295, 0.33858], -[14963, 0.94162, 0.69739, 0.18479], -[14964, 1.00000, 0.62990, 0.22500], -[14965, 0.93052, 0.65475, 0.07821], -[14966, 0.95540, 0.68322, 0.19495], -[14967, 0.77490, 0.91078, 0.29308], -[14968, 0.87769, 0.77148, 0.17229], -[14969, 0.82363, 0.88934, 0.43967], -[14970, 0.85652, 0.77550, 0.12837], -[14971, 0.95207, 0.68004, 0.17710], -[14972, 0.74502, 0.90569, 0.18674], -[14973, 0.85469, 0.84776, 0.34405], -[14974, 0.89037, 0.82180, 0.42434], -[14975, 0.79283, 0.91910, 0.47305], -[14976, 0.94134, 0.68617, 0.15776], -[14977, 0.82476, 0.73750, 0.00000], -[14978, 0.57471, 0.98732, 0.08874], -[14979, 0.91687, 0.66538, 0.06311], -[14980, 0.80000, 0.91340, 0.50000], -[14981, 0.87641, 0.70923, 0.04916], -[14982, 0.89548, 0.75399, 0.17689], -[14983, 0.97692, 0.58957, 0.08426], -[14984, 0.67524, 1.00000, 0.36250], -[14985, 0.93396, 0.71448, 0.19649], -[14986, 0.98198, 0.71337, 0.45859], -[14987, 0.71122, 0.92975, 0.17646], -[14988, 1.00000, 0.47500, 0.00000], -[14989, 0.47500, 1.00000, 0.00000], -[14990, 1.00000, 0.50000, 0.02500], -[14991, 0.50000, 1.00000, 0.02500], -[14992, 0.97706, 0.57669, 0.06592], -[14993, 1.00000, 0.67321, 0.35000], -[14994, 0.77061, 0.92740, 0.35218], -[14995, 1.00000, 0.54330, 0.07500], -[14996, 0.86496, 0.82390, 0.27863], -[14997, 0.81259, 0.80072, 0.08210], -[14998, 0.96396, 0.66242, 0.17115], -[14999, 0.86806, 0.68750, 0.00000], -[15000, 0.75204, 0.88438, 0.14154], -[15001, 0.96351, 0.59779, 0.06351], -[15002, 0.86085, 0.85489, 0.43256], -[15003, 0.93079, 0.70881, 0.17178], -[15004, 0.69486, 0.86250, 0.00000], -[15005, 0.52369, 1.00000, 0.05000], -[15006, 0.86861, 0.84975, 0.48527], -[15007, 0.82534, 0.84120, 0.20329], -[15008, 0.75209, 0.86991, 0.10695], -[15009, 0.98423, 0.67474, 0.26989], -[15010, 0.73881, 0.87275, 0.08843], -[15011, 0.87321, 0.73888, 0.08949], -[15012, 0.99016, 0.68831, 0.34902], -[15013, 0.95722, 0.71095, 0.26474], -[15014, 0.87103, 0.84665, 0.45962], -[15015, 0.81481, 0.86572, 0.24724], -[15016, 0.79448, 0.91621, 0.41826], -[15017, 0.65012, 0.97970, 0.19199], -[15018, 0.86427, 0.85017, 0.41265], -[15019, 0.81898, 0.85365, 0.22081], -[15020, 0.90427, 0.78735, 0.30054], -[15021, 0.76656, 0.93867, 0.40632], -[15022, 0.76771, 0.82015, 0.03581], -[15023, 0.82830, 0.79325, 0.09709], -[15024, 0.71576, 0.94613, 0.23502], -[15025, 0.71652, 0.97906, 0.42386], -[15026, 0.75000, 0.95670, 0.50000], -[15027, 0.95466, 0.56250, 0.00000], -[15028, 0.65359, 1.00000, 0.27500], -[15029, 0.58864, 1.00000, 0.13750], -[15030, 0.88359, 0.68618, 0.02417], -[15031, 0.67846, 0.95267, 0.16821], -[15032, 0.61029, 1.00000, 0.17500], -[15033, 0.77937, 0.93012, 0.42561], -[15034, 0.85384, 0.74350, 0.05680], -[15035, 0.70589, 0.95582, 0.24213], -[15036, 0.88709, 0.82936, 0.43862], -[15037, 0.64527, 0.91985, 0.03518], -[15038, 0.61252, 0.97826, 0.11732], -[15039, 0.88423, 0.81092, 0.30193], -[15040, 0.97631, 0.52500, 0.00000], -[15041, 0.80079, 0.89513, 0.30903], -[15042, 0.81400, 0.77474, 0.03505], -[15043, 0.81897, 0.88896, 0.36564], -[15044, 0.97569, 0.69025, 0.27466], -[15045, 0.60371, 0.95987, 0.06011], -[15046, 0.79728, 0.79007, 0.03150], -[15047, 0.67266, 0.93485, 0.10879], -[15048, 0.71521, 0.97032, 0.33734], -[15049, 0.77476, 0.92245, 0.33148], -[15050, 0.85000, 0.87010, 0.50000], -[15051, 0.72826, 0.95907, 0.32855], -[15052, 0.68616, 0.97706, 0.26729], -[15053, 0.84682, 0.76798, 0.08434], -[15054, 0.74882, 0.85859, 0.07345], -[15055, 0.63617, 0.93492, 0.05145], -[15056, 0.72398, 0.87911, 0.07208], -[15057, 0.97986, 0.59997, 0.09974], -[15058, 0.63003, 0.96527, 0.11038], -[15059, 0.93301, 0.60000, 0.00000], -[15060, 0.94691, 0.64370, 0.08819], -[15061, 0.85317, 0.84216, 0.29135], -[15062, 0.67288, 0.92266, 0.07975], -[15063, 0.63510, 0.98605, 0.17582], -[15064, 0.76070, 0.94264, 0.38375], -[15065, 0.78146, 0.78750, 0.00000], -[15066, 0.89765, 0.69729, 0.06543], -[15067, 0.91250, 0.80514, 0.50000], -[15068, 1.00000, 0.65155, 0.26250], -[15069, 0.82687, 0.78223, 0.06947], -[15070, 0.56544, 0.96271, 0.01584], -[15071, 0.54875, 0.97773, 0.02684], -[15072, 0.69786, 0.91121, 0.09540], -[15073, 0.94317, 0.61867, 0.04304], -[15074, 0.85573, 0.86528, 0.48057], -[15075, 0.78058, 0.82089, 0.05481], -[15076, 0.93727, 0.76802, 0.38583], -[15077, 0.98073, 0.71232, 0.38948], -[15078, 0.56699, 1.00000, 0.10000], -[15079, 0.98117, 0.67456, 0.24736], -[15080, 0.81011, 0.83571, 0.14372], -[15081, 0.90252, 0.77593, 0.24445], -[15082, 0.85209, 0.81414, 0.19495], -[15083, 0.90397, 0.76463, 0.21694], -[15084, 0.63194, 1.00000, 0.21250], -[15085, 0.81076, 0.89200, 0.32941], -[15086, 0.79159, 0.86272, 0.16626], -[15087, 0.87307, 0.83918, 0.37410], -[15088, 0.67524, 1.00000, 0.33750], -[15089, 0.90992, 0.71925, 0.12976], -[15090, 0.70896, 0.96022, 0.25967], -[15091, 0.80543, 0.86673, 0.21283], -[15092, 0.85000, 0.82244, 0.21096], -[15093, 0.84394, 0.83871, 0.24155], -[15094, 0.70522, 0.96848, 0.28273], -[15095, 0.65841, 0.96257, 0.14988], -[15096, 0.97853, 0.72438, 0.47912], -[15097, 0.83715, 0.81036, 0.14608], -[15098, 0.82888, 0.88869, 0.42218], -[15099, 0.63296, 0.94819, 0.07181], -[15100, 0.80395, 0.91361, 0.45372], -[15101, 0.85965, 0.71398, 0.01551], -[15102, 1.00000, 0.67321, 0.32500], -[15103, 1.00000, 0.60825, 0.16250], -[15104, 0.58859, 0.97665, 0.07140], -[15105, 0.62311, 0.98447, 0.14424], -[15106, 0.95867, 0.62626, 0.08398], -[15107, 0.96612, 0.71894, 0.31535], -[15108, 0.85718, 0.82451, 0.23583], -[15109, 0.76487, 0.94805, 0.47509], -[15110, 0.70252, 0.91995, 0.11956], -[15111, 0.97972, 0.62427, 0.13254], -[15112, 0.92615, 0.71020, 0.14995], -[15113, 0.98511, 0.68670, 0.29339], -[15114, 1.00000, 0.58660, 0.12500], -[15115, 0.71798, 0.92109, 0.15236], -[15116, 0.91943, 0.65583, 0.04240], -[15117, 0.91235, 0.70480, 0.10527], -[15118, 0.71433, 0.98714, 0.48326], -[15119, 0.83029, 0.82549, 0.16193], -[15120, 0.90905, 0.80030, 0.36477], -[15121, 0.78476, 0.93091, 0.44792], -[15122, 0.97245, 0.68282, 0.22922], -[15123, 1.00000, 0.69571, 0.46458], -[15124, 0.77769, 0.91816, 0.30610], -[15125, 0.95482, 0.66001, 0.12821], -[15126, 0.79486, 0.81928, 0.07272], -[15127, 0.80076, 0.82954, 0.10453], -[15128, 0.97544, 0.72871, 0.44291], -[15129, 0.77780, 0.85740, 0.11835], -[15130, 0.84562, 0.87376, 0.41493], -[15131, 0.79028, 0.89537, 0.25593], -[15132, 0.94227, 0.60832, 0.02257], -[15133, 0.71651, 0.85000, 0.00000], -[15134, 0.77211, 0.87508, 0.14772], -[15135, 0.79455, 0.91595, 0.37432], -[15136, 0.79467, 0.88411, 0.22997], -[15137, 0.87584, 0.79891, 0.21581], -[15138, 0.89326, 0.80121, 0.28491], -[15139, 0.81358, 0.78983, 0.05236], -[15140, 0.75131, 0.95497, 0.40100], -[15141, 0.70203, 0.93626, 0.15815], -[15142, 0.69689, 1.00000, 0.47500], -[15143, 0.92391, 0.78439, 0.36758], -[15144, 0.88639, 0.80122, 0.25755], -[15145, 0.78694, 0.92581, 0.39929], -[15146, 0.85864, 0.85515, 0.36543], -[15147, 0.91183, 0.80601, 0.42486], -[15148, 1.00000, 0.69486, 0.43750], -[15149, 1.00000, 0.62990, 0.20000], -[15150, 0.96034, 0.75130, 0.48911], -[15151, 0.91136, 0.63750, 0.00000], -[15152, 0.84654, 0.86931, 0.37886], -[15153, 0.89526, 0.75208, 0.15367], -[15154, 0.80633, 0.85487, 0.17396], -[15155, 0.96024, 0.75019, 0.45085], -[15156, 0.89217, 0.69406, 0.04218], -[15157, 0.64942, 0.96125, 0.12375], -[15158, 0.93513, 0.69377, 0.13727], -[15159, 0.77046, 0.85732, 0.10134], -[15160, 0.92780, 0.74018, 0.21911], -[15161, 0.76505, 0.87206, 0.12343], -[15162, 0.90550, 0.81683, 0.47855], -[15163, 0.76041, 0.91892, 0.24513], -[15164, 0.90762, 0.68195, 0.05410], -[15165, 0.89803, 0.82440, 0.45819], -[15166, 0.87215, 0.79075, 0.18069], -[15167, 0.77187, 0.94342, 0.45382], -[15168, 0.78739, 0.80837, 0.03680], -[15169, 0.87437, 0.77180, 0.14233], -[15170, 0.69689, 1.00000, 0.45000], -[15171, 0.93894, 0.74945, 0.28814], -[15172, 0.80934, 0.88910, 0.29325], -[15173, 0.98143, 0.70600, 0.33673], -[15174, 0.73674, 0.96029, 0.34676], -[15175, 0.85769, 0.84707, 0.31197], -[15176, 1.00000, 0.52221, 0.03542], -[15177, 0.82922, 0.86829, 0.28275], -[15178, 0.94019, 0.77709, 0.46927], -[15179, 0.54534, 1.00000, 0.06250], -[15180, 0.97016, 0.65470, 0.15487], -[15181, 0.62562, 0.93947, 0.03634], -[15182, 0.72911, 0.95544, 0.28885], -[15183, 0.65462, 0.97552, 0.16987], -[15184, 0.93544, 0.73635, 0.23162], -[15185, 1.00000, 0.56495, 0.08750], -[15186, 0.81394, 0.90718, 0.43699], -[15187, 0.71738, 0.97709, 0.35800], -[15188, 0.91682, 0.80453, 0.45773], -[15189, 0.74058, 0.95091, 0.30768], -[15190, 0.65359, 1.00000, 0.25000], -[15191, 0.96750, 0.67286, 0.18230], -[15192, 0.93748, 0.68120, 0.11677], -[15193, 0.94689, 0.75679, 0.35691], -[15194, 1.00000, 0.70000, 0.50000], -[15195, 0.70000, 1.00000, 0.50000], -[15196, 0.74884, 0.94064, 0.28887], -[15197, 0.82258, 0.82717, 0.14037], -[15198, 1.00000, 0.69486, 0.41250], -[15199, 0.72705, 0.87466, 0.05629], -[15200, 0.58507, 0.96194, 0.02774], -[15201, 0.92385, 0.77489, 0.30840], -[15202, 0.55725, 0.98697, 0.04606], -[15203, 0.77019, 0.84846, 0.07849], -[15204, 0.62720, 0.96344, 0.08846], -[15205, 0.77640, 0.89977, 0.21955], -[15206, 0.67524, 1.00000, 0.31250], -[15207, 0.69689, 1.00000, 0.42500], -[15208, 0.70580, 0.87748, 0.02750], -[15209, 0.82094, 0.84876, 0.18843], -[15210, 0.60364, 0.95692, 0.04028], -[15211, 0.92303, 0.71012, 0.13228], -[15212, 0.87360, 0.76356, 0.11874], -[15213, 0.74551, 0.90799, 0.16622], -[15214, 0.86783, 0.78944, 0.16012], -[15215, 0.86243, 0.75361, 0.07555], -[15216, 0.79008, 0.90511, 0.27992], -[15217, 0.76886, 0.93106, 0.31561], -[15218, 0.84641, 0.72500, 0.00000], -[15219, 0.91783, 0.76965, 0.26037], -[15220, 0.88790, 0.78014, 0.19104], -[15221, 0.82892, 0.88368, 0.34330], -[15222, 0.70403, 0.89660, 0.06060], -[15223, 0.93063, 0.75303, 0.25566], -[15224, 0.92562, 0.68974, 0.09957], -[15225, 0.95702, 0.59072, 0.02223], -[15226, 0.96775, 0.58934, 0.04249], -[15227, 1.00000, 0.67321, 0.30000], -[15228, 0.83666, 0.88469, 0.39720], -[15229, 0.73356, 0.85005, 0.01772], -[15230, 0.80956, 0.86313, 0.19514], -[15231, 0.95853, 0.74690, 0.37079], -[15232, 0.87399, 0.84169, 0.35492], -[15233, 1.00000, 0.65155, 0.23750], -[15234, 0.94698, 0.63919, 0.06623], -[15235, 0.98988, 0.52856, 0.01596], -[15236, 0.90000, 0.82679, 0.50000], -[15237, 0.88303, 0.81596, 0.28075], -[15238, 0.92942, 0.76301, 0.28150], -[15239, 0.87916, 0.70501, 0.02675], -[15240, 0.87576, 0.80950, 0.23220], -[15241, 0.95387, 0.75950, 0.41428], -[15242, 0.98398, 0.55573, 0.03401], -[15243, 0.91111, 0.79767, 0.33299], -[15244, 0.87135, 0.84066, 0.33158], -[15245, 0.91639, 0.73491, 0.16162], -[15246, 0.78750, 0.93505, 0.50000], -[15247, 0.76776, 0.92882, 0.29430], -[15248, 0.93778, 0.77339, 0.36990], -[15249, 0.97279, 0.60771, 0.07704], -[15250, 0.74998, 0.85533, 0.05223], -[15251, 0.62310, 0.95147, 0.05161], -[15252, 0.95485, 0.70343, 0.20275], -[15253, 0.61029, 1.00000, 0.15000], -[15254, 0.65564, 0.93742, 0.06828], -[15255, 0.74995, 0.96538, 0.47434], -[15256, 0.97560, 0.69634, 0.25819], -[15257, 0.95685, 0.65214, 0.10709], -[15258, 0.95985, 0.74165, 0.34551], -[15259, 0.68130, 0.94336, 0.12430], -[15260, 0.69013, 0.88575, 0.01576], -[15261, 0.75714, 0.94925, 0.35506], -[15262, 1.00000, 0.69486, 0.38750], -[15263, 0.75922, 0.95696, 0.44195], -[15264, 0.57530, 0.95635, 0.00000], -[15265, 0.80311, 0.77500, 0.00000], -[15266, 0.69689, 1.00000, 0.40000], -[15267, 0.89147, 0.83140, 0.40128], -[15268, 0.89121, 0.79274, 0.22944], -[15269, 0.83636, 0.80516, 0.11499], -[15270, 0.53750, 0.97835, 0.00000], -[15271, 0.71947, 0.98084, 0.37185], -[15272, 0.88999, 0.82879, 0.36872], -[15273, 0.73816, 0.83750, 0.00000], -[15274, 0.71748, 0.94319, 0.19682], -[15275, 0.86910, 0.76038, 0.09645], -[15276, 0.70839, 0.98779, 0.36237], -[15277, 0.78645, 0.84363, 0.09217], -[15278, 0.83750, 0.89175, 0.50000], -[15279, 0.72136, 0.98243, 0.39468], -[15280, 0.58864, 1.00000, 0.11250], -[15281, 0.91547, 0.78119, 0.28007], -[15282, 0.92476, 0.63918, 0.01709], -[15283, 0.63194, 1.00000, 0.18750], -[15284, 0.92758, 0.73151, 0.18135], -[15285, 0.88971, 0.67500, 0.00000], -[15286, 0.92350, 0.70497, 0.11591], -[15287, 0.97171, 0.57354, 0.02630], -[15288, 1.00000, 0.54330, 0.05000], -[15289, 0.84844, 0.76530, 0.06159], -[15290, 0.72611, 0.98365, 0.44421], -[15291, 0.74548, 0.92888, 0.21806], -[15292, 0.86886, 0.72716, 0.03696], -[15293, 0.83921, 0.88214, 0.37468], -[15294, 0.83380, 0.86240, 0.25664], -[15295, 0.69453, 0.97446, 0.24205], -[15296, 0.67600, 0.98443, 0.23085], -[15297, 0.74553, 0.96821, 0.42734], -[15298, 0.84568, 0.88471, 0.47359], -[15299, 0.73483, 0.97195, 0.38194], -[15300, 0.89569, 0.74955, 0.13295], -[15301, 0.60825, 0.93750, 0.00000], -[15302, 0.94001, 0.67236, 0.09583], -[15303, 0.84168, 0.75091, 0.02359], -[15304, 0.66588, 0.95951, 0.13229], -[15305, 0.76108, 0.94373, 0.32819], -[15306, 0.83400, 0.85737, 0.23778], -[15307, 0.81630, 0.91253, 0.47785], -[15308, 0.83262, 0.87996, 0.32095], -[15309, 0.52369, 1.00000, 0.02500], -[15310, 1.00000, 0.50000, 0.00000], -[15311, 0.50000, 1.00000, 0.00000], -[15312, 0.89899, 0.78131, 0.21464], -[15313, 0.73054, 0.91281, 0.13501], -[15314, 0.69693, 0.89539, 0.03880], -[15315, 0.86551, 0.85923, 0.38696], -[15316, 0.64664, 0.96338, 0.10763], -[15317, 0.69746, 0.94101, 0.14188], -[15318, 0.88351, 0.84630, 0.44035], -[15319, 0.67099, 0.90927, 0.02734], -[15320, 0.90562, 0.67886, 0.03143], -[15321, 0.71979, 0.95761, 0.24399], -[15322, 0.97452, 0.71340, 0.29470], -[15323, 0.86094, 0.80952, 0.17701], -[15324, 0.90553, 0.76889, 0.20050], -[15325, 0.97685, 0.73937, 0.50000], -[15326, 0.66753, 0.92261, 0.04821], -[15327, 0.95285, 0.68021, 0.13889], -[15328, 0.73750, 0.97835, 0.50000], -[15329, 0.87582, 0.83098, 0.29145], -[15330, 0.67524, 1.00000, 0.28750], -[15331, 0.80882, 0.78133, 0.01367], -[15332, 0.97486, 0.70510, 0.26831], -[15333, 0.92892, 0.73893, 0.19621], -[15334, 0.97395, 0.64650, 0.13299], -[15335, 0.69689, 1.00000, 0.37500], -[15336, 0.84360, 0.83028, 0.18329], -[15337, 1.00000, 0.60825, 0.13750], -[15338, 0.85524, 0.85977, 0.32425], -[15339, 0.79536, 0.86259, 0.14659], -[15340, 0.93212, 0.79166, 0.42213], -[15341, 0.81697, 0.90995, 0.42074], -[15342, 1.00000, 0.69486, 0.36250], -[15343, 0.87874, 0.73053, 0.05742], -[15344, 0.92498, 0.80367, 0.48147], -[15345, 0.72892, 0.86747, 0.03297], -[15346, 0.77075, 0.84322, 0.05628], -[15347, 0.96096, 0.75257, 0.38931], -[15348, 0.73092, 0.94169, 0.21530], -[15349, 0.56699, 1.00000, 0.07500], -[15350, 0.92175, 0.80213, 0.40452], -[15351, 0.75249, 0.88937, 0.11913], -[15352, 0.96101, 0.73373, 0.29899], -[15353, 0.86401, 0.79229, 0.14214], -[15354, 0.73036, 0.89410, 0.08827], -[15355, 0.62990, 0.92500, 0.00000], -[15356, 1.00000, 0.62990, 0.17500], -[15357, 0.81356, 0.80726, 0.06531], -[15358, 0.84838, 0.85040, 0.25576], -[15359, 0.69114, 0.93040, 0.10086], -[15360, 0.84171, 0.84624, 0.22035], -[15361, 0.65359, 1.00000, 0.22500], -[15362, 0.86588, 0.83740, 0.27206], -[15363, 0.96146, 0.74047, 0.32610], -[15364, 0.89815, 0.81463, 0.31889], -[15365, 0.98188, 0.65704, 0.17199], -[15366, 0.78917, 0.87523, 0.16129], -[15367, 0.84530, 0.88690, 0.45073], -[15368, 0.98608, 0.72485, 0.42366], -[15369, 0.61002, 0.97714, 0.07960], -[15370, 0.79061, 0.92592, 0.35402], -[15371, 0.95184, 0.69904, 0.16968], -[15372, 1.00000, 0.67321, 0.27500], -[15373, 0.74027, 0.92529, 0.18424], -[15374, 0.76371, 0.91196, 0.20162], -[15375, 1.00000, 0.58660, 0.10000], -[15376, 0.71273, 0.97745, 0.29821], -[15377, 0.98669, 0.64049, 0.15308], -[15378, 0.79730, 0.88209, 0.19930], -[15379, 0.81635, 0.90249, 0.34727], -[15380, 0.84623, 0.86542, 0.30192], -[15381, 0.75580, 0.84510, 0.03214], -[15382, 0.84597, 0.76094, 0.04212], -[15383, 0.98552, 0.70667, 0.31612], -[15384, 0.96905, 0.74847, 0.42752], -[15385, 0.88890, 0.82963, 0.33853], -[15386, 0.93058, 0.78426, 0.34648], -[15387, 0.77711, 0.91251, 0.23863], -[15388, 0.66230, 0.91041, 0.01276], -[15389, 0.97604, 0.62230, 0.09374], -[15390, 0.69124, 0.97337, 0.21771], -[15391, 0.87298, 0.82465, 0.24923], -[15392, 0.98588, 0.69849, 0.28680], -[15393, 0.74736, 0.97190, 0.45260], -[15394, 0.93607, 0.79225, 0.46020], -[15395, 0.98125, 0.72372, 0.36250], -[15396, 0.89535, 0.71409, 0.05952], -[15397, 0.97631, 0.55000, 0.00000], -[15398, 0.82802, 0.88265, 0.29719], -[15399, 0.88626, 0.82900, 0.31772], -[15400, 0.92210, 0.72693, 0.14326], -[15401, 0.76399, 0.91903, 0.22096], -[15402, 0.91336, 0.70418, 0.08018], -[15403, 0.82027, 0.88164, 0.26286], -[15404, 0.86009, 0.72986, 0.01632], -[15405, 0.88776, 0.74926, 0.10391], -[15406, 0.95466, 0.58750, 0.00000], -[15407, 0.76174, 0.93446, 0.26935], -[15408, 0.65155, 0.91250, 0.00000], -[15409, 1.00000, 0.65155, 0.21250], -[15410, 0.86286, 0.77993, 0.10675], -[15411, 0.88750, 0.84845, 0.50000], -[15412, 0.74198, 0.96894, 0.36396], -[15413, 0.82623, 0.85946, 0.20577], -[15414, 0.75981, 0.82500, 0.00000], -[15415, 0.93743, 0.65768, 0.05652], -[15416, 0.90972, 0.72337, 0.10360], -[15417, 0.60408, 0.95416, 0.01749], -[15418, 0.69689, 1.00000, 0.35000], -[15419, 0.96442, 0.61947, 0.05918], -[15420, 0.85074, 0.81981, 0.16484], -[15421, 0.71797, 0.91833, 0.11348], -[15422, 0.75427, 0.83644, 0.01043], -[15423, 0.97686, 0.63579, 0.11288], -[15424, 0.73989, 0.94287, 0.23171], -[15425, 0.71300, 0.95780, 0.21227], -[15426, 0.91636, 0.75507, 0.18577], -[15427, 0.71016, 0.98976, 0.34270], -[15428, 0.70568, 0.95203, 0.17689], -[15429, 0.86927, 0.81903, 0.21234], -[15430, 1.00000, 0.69486, 0.33750], -[15431, 0.96658, 0.72510, 0.27792], -[15432, 0.88509, 0.84797, 0.41626], -[15433, 0.73631, 0.98310, 0.46929], -[15434, 0.73286, 0.92933, 0.16985], -[15435, 0.59292, 0.97617, 0.04674], -[15436, 0.78476, 0.88943, 0.17895], -[15437, 0.90190, 0.81054, 0.30045], -[15438, 0.80172, 0.92930, 0.43531], -[15439, 0.97619, 0.72853, 0.33612], -[15440, 1.00000, 0.56495, 0.06250], -[15441, 0.67182, 0.97966, 0.18450], -[15442, 0.88623, 0.79580, 0.19652], -[15443, 0.86224, 0.87513, 0.46084], -[15444, 0.76790, 0.90497, 0.18015], -[15445, 0.96888, 0.70534, 0.22657], -[15446, 0.95830, 0.76714, 0.43548], -[15447, 0.93301, 0.62500, 0.00000], -[15448, 0.86806, 0.71250, 0.00000], -[15449, 0.64434, 0.98201, 0.13672], -[15450, 0.66635, 0.95555, 0.10702], -[15451, 0.82476, 0.76250, 0.00000], -[15452, 0.68462, 0.96858, 0.17611], -[15453, 0.84907, 0.88673, 0.43225], -[15454, 0.79904, 0.91498, 0.30955], -[15455, 0.79442, 0.86033, 0.12480], -[15456, 0.76166, 0.87217, 0.08619], -[15457, 0.83733, 0.77900, 0.04825], -[15458, 0.94468, 0.78502, 0.44018], -[15459, 0.75933, 0.93465, 0.25069], -[15460, 0.67524, 1.00000, 0.26250], -[15461, 0.67214, 0.97108, 0.15700], -[15462, 0.91126, 0.81753, 0.38257], -[15463, 0.94376, 0.64157, 0.04146], -[15464, 0.75565, 0.96280, 0.37894], -[15465, 0.91131, 0.73410, 0.12132], -[15466, 0.72349, 0.87869, 0.03377], -[15467, 0.96288, 0.68577, 0.16003], -[15468, 0.97456, 0.69028, 0.20545], -[15469, 0.61029, 1.00000, 0.12500], -[15470, 0.70288, 0.91524, 0.07397], -[15471, 0.67321, 0.90000, 0.00000], -[15472, 0.63194, 1.00000, 0.16250], -[15473, 0.78203, 0.92103, 0.26866], -[15474, 0.81853, 0.83439, 0.11635], -[15475, 0.63801, 0.98229, 0.12356], -[15476, 0.97929, 0.73515, 0.38082], -[15477, 0.91685, 0.69495, 0.06393], -[15478, 0.85710, 0.79717, 0.12079], -[15479, 0.94772, 0.71640, 0.17983], -[15480, 0.74218, 0.97652, 0.40235], -[15481, 1.00000, 0.71651, 0.47500], -[15482, 0.54611, 1.00000, 0.03542], -[15483, 0.98100, 0.74143, 0.45531], -[15484, 0.90268, 0.82414, 0.35836], -[15485, 0.79161, 0.94176, 0.47653], -[15486, 0.94202, 0.76682, 0.30280], -[15487, 0.81612, 0.91160, 0.36835], -[15488, 0.80596, 0.91350, 0.32539], -[15489, 0.98586, 0.73020, 0.40240], -[15490, 0.92036, 0.77217, 0.23266], -[15491, 0.87519, 0.86506, 0.47603], -[15492, 0.76592, 0.89875, 0.15286], -[15493, 0.82500, 0.91340, 0.50000], -[15494, 0.89469, 0.77398, 0.16029], -[15495, 0.96225, 0.60986, 0.03378], -[15496, 0.97793, 0.70253, 0.24438], -[15497, 0.80737, 0.92927, 0.48763], -[15498, 0.72564, 0.86738, 0.01349], -[15499, 0.95625, 0.75100, 0.30710], -[15500, 0.64479, 0.93267, 0.02034], -[15501, 1.00000, 0.67321, 0.25000], -[15502, 0.95423, 0.75965, 0.33241], -[15503, 0.81364, 0.85636, 0.15295], -[15504, 1.00000, 0.71651, 0.45000], -[15505, 0.78745, 0.87067, 0.12887], -[15506, 0.77500, 0.95670, 0.50000], -[15507, 0.64763, 0.95885, 0.07903], -[15508, 0.95047, 0.73248, 0.22410], -[15509, 0.83595, 0.84281, 0.17300], -[15510, 0.89419, 0.82049, 0.29183], -[15511, 0.85749, 0.82172, 0.17480], -[15512, 0.69689, 1.00000, 0.32500], -[15513, 0.95000, 0.78349, 0.50000], -[15514, 0.95597, 0.77507, 0.45823], -[15515, 0.88662, 0.85449, 0.48635], -[15516, 0.83278, 0.89928, 0.38050], -[15517, 0.79460, 0.90440, 0.24073], -[15518, 0.58864, 1.00000, 0.08750], -[15519, 0.69183, 0.95928, 0.15640], -[15520, 0.93600, 0.67554, 0.07049], -[15521, 0.65359, 1.00000, 0.20000], -[15522, 0.97157, 0.75656, 0.46978], -[15523, 0.70807, 0.97037, 0.22743], -[15524, 0.94943, 0.77783, 0.39562], -[15525, 0.62340, 0.98340, 0.09785], -[15526, 0.89039, 0.81954, 0.26960], -[15527, 0.86285, 0.87546, 0.41793], -[15528, 0.87549, 0.86264, 0.41432], -[15529, 1.00000, 0.69486, 0.31250], -[15530, 0.81841, 0.91472, 0.39263], -[15531, 0.95954, 0.77271, 0.48083], -[15532, 0.83591, 0.90346, 0.44346], -[15533, 0.85790, 0.87059, 0.34414], -[15534, 0.98526, 0.55708, 0.01301], -[15535, 0.78380, 0.81891, 0.01672], -[15536, 0.81254, 0.89025, 0.24302], -[15537, 0.66644, 0.95237, 0.09049], -[15538, 0.80335, 0.84764, 0.10618], -[15539, 0.92545, 0.75919, 0.20645], -[15540, 1.00000, 0.71651, 0.42500], -[15541, 0.71868, 0.91374, 0.09057], -[15542, 0.71962, 1.00000, 0.46458], -[15543, 0.83477, 0.77274, 0.02546], -[15544, 1.00000, 0.62990, 0.15000], -[15545, 0.73948, 0.90519, 0.10873], -[15546, 0.91136, 0.66250, 0.00000], -[15547, 0.70286, 0.98998, 0.28674], -[15548, 0.65418, 0.94192, 0.04742], -[15549, 0.90272, 0.83934, 0.47499], -[15550, 0.78379, 0.94760, 0.41149], -[15551, 1.00000, 0.60825, 0.11250], -[15552, 0.71854, 1.00000, 0.43750], -[15553, 0.75156, 0.89020, 0.09620], -[15554, 0.69486, 0.88750, 0.00000], -[15555, 0.72139, 0.97675, 0.28544], -[15556, 0.97876, 0.74541, 0.41625], -[15557, 0.80280, 0.82022, 0.04903], -[15558, 0.93268, 0.80457, 0.44112], -[15559, 0.76326, 0.94873, 0.30482], -[15560, 1.00000, 0.54330, 0.02500], -[15561, 0.78146, 0.81250, 0.00000], -[15562, 0.96964, 0.76203, 0.50000], -[15563, 0.91125, 0.79260, 0.25028], -[15564, 0.84677, 0.78342, 0.06383], -[15565, 0.76941, 0.96004, 0.41419], -[15566, 0.85664, 0.85824, 0.27499], -[15567, 0.89386, 0.84885, 0.46068], -[15568, 0.71581, 0.92551, 0.10993], -[15569, 0.85076, 0.79772, 0.09872], -[15570, 0.78818, 0.86337, 0.10684], -[15571, 0.90495, 0.81051, 0.28689], -[15572, 0.88639, 0.85077, 0.39142], -[15573, 0.57471, 0.98209, 0.02398], -[15574, 0.96334, 0.72567, 0.24153], -[15575, 0.98179, 0.59699, 0.05141], -[15576, 0.91424, 0.82317, 0.40980], -[15577, 0.94633, 0.75658, 0.26808], -[15578, 0.84033, 0.79861, 0.07828], -[15579, 0.79089, 0.93858, 0.37557], -[15580, 0.93646, 0.79542, 0.38858], -[15581, 0.94400, 0.79421, 0.48657], -[15582, 0.82777, 0.84614, 0.15221], -[15583, 1.00000, 0.65155, 0.18750], -[15584, 0.72259, 0.98373, 0.32005], -[15585, 0.78356, 0.90435, 0.19925], -[15586, 0.83891, 0.82321, 0.12471], -[15587, 0.72741, 0.96874, 0.26602], -[15588, 0.95914, 0.76603, 0.37400], -[15589, 0.87500, 0.87010, 0.50000], -[15590, 0.96049, 0.73702, 0.26116], -[15591, 0.76794, 0.96515, 0.46026], -[15592, 0.75534, 0.96278, 0.34072], -[15593, 0.98944, 0.57708, 0.04045], -[15594, 0.75655, 0.92394, 0.18808], -[15595, 1.00000, 0.71651, 0.40000], -[15596, 0.81823, 0.82285, 0.07939], -[15597, 0.56250, 0.97835, 0.00000], -[15598, 0.72853, 0.98410, 0.34359], -[15599, 0.90936, 0.81932, 0.34043], -[15600, 0.81428, 0.85177, 0.13205], -[15601, 0.71854, 1.00000, 0.41250], -[15602, 0.56699, 1.00000, 0.05000], -[15603, 0.73446, 0.97273, 0.30398], -[15604, 0.95236, 0.66019, 0.07381], -[15605, 0.87588, 0.80395, 0.16665], -[15606, 0.80817, 0.93273, 0.46009], -[15607, 1.00000, 0.58660, 0.07500], -[15608, 0.67524, 1.00000, 0.23750], -[15609, 0.70771, 0.98387, 0.26319], -[15610, 0.98125, 0.74953, 0.48216], -[15611, 0.95149, 0.72843, 0.20151], -[15612, 0.83316, 0.90647, 0.40344], -[15613, 0.60000, 0.95670, 0.00000], -[15614, 0.96024, 0.74553, 0.28208], -[15615, 0.74741, 0.98125, 0.43750], -[15616, 0.80792, 0.92945, 0.40634], -[15617, 0.82286, 0.87729, 0.21932], -[15618, 0.52500, 1.00000, 0.00000], -[15619, 1.00000, 0.72500, 0.50000], -[15620, 1.00000, 0.52500, 0.00000], -[15621, 0.72500, 1.00000, 0.50000], -[15622, 0.80662, 0.90418, 0.26029], -[15623, 0.69689, 1.00000, 0.30000], -[15624, 0.95268, 0.78197, 0.41887], -[15625, 0.84732, 0.88675, 0.35369], -[15626, 0.81981, 0.90468, 0.31223], -[15627, 0.77153, 0.89160, 0.13178], -[15628, 0.62731, 0.97157, 0.06599], -[15629, 0.74015, 0.94056, 0.19434], -[15630, 0.80635, 0.91227, 0.29134], -[15631, 0.64635, 0.95489, 0.05645], -[15632, 0.89558, 0.73820, 0.07603], -[15633, 0.77147, 0.83827, 0.02144], -[15634, 0.90309, 0.80485, 0.24763], -[15635, 0.87668, 0.78566, 0.12417], -[15636, 0.93750, 0.80514, 0.50000], -[15637, 0.78778, 0.83130, 0.03565], -[15638, 0.83598, 0.81468, 0.09409], -[15639, 0.81919, 0.79597, 0.02800], -[15640, 0.63792, 0.95021, 0.03333], -[15641, 0.86357, 0.74921, 0.03029], -[15642, 0.97214, 0.66084, 0.11792], -[15643, 0.83735, 0.90879, 0.47178], -[15644, 0.90786, 0.79462, 0.23112], -[15645, 0.88171, 0.86503, 0.45252], -[15646, 1.00000, 0.69486, 0.28750], -[15647, 0.77497, 0.95434, 0.37080], -[15648, 0.84763, 0.84836, 0.20024], -[15649, 0.82602, 0.91854, 0.45471], -[15650, 0.72320, 0.90546, 0.06963], -[15651, 0.82216, 0.89644, 0.27901], -[15652, 0.79019, 0.92799, 0.29299], -[15653, 0.77298, 0.95903, 0.39324], -[15654, 0.90063, 0.69890, 0.02138], -[15655, 0.79284, 0.93160, 0.32047], -[15656, 0.95270, 0.62867, 0.02470], -[15657, 0.92465, 0.78270, 0.25262], -[15658, 0.74795, 0.95763, 0.27123], -[15659, 1.00000, 0.67321, 0.22500], -[15660, 0.84641, 0.75000, 0.00000], -[15661, 0.71854, 1.00000, 0.38750], -[15662, 0.71651, 0.87500, 0.00000], -[15663, 1.00000, 0.71651, 0.37500], -[15664, 0.80607, 0.87939, 0.17452], -[15665, 0.93161, 0.78785, 0.29840], -[15666, 0.97348, 0.67049, 0.13654], -[15667, 0.86393, 0.84536, 0.23849], -[15668, 0.68615, 0.94190, 0.08569], -[15669, 0.79392, 0.83950, 0.05892], -[15670, 0.74926, 0.88684, 0.07360], -[15671, 0.74953, 0.98378, 0.48805], -[15672, 0.82884, 0.91446, 0.41839], -[15673, 0.78937, 0.93866, 0.33920], -[15674, 0.91741, 0.82703, 0.43222], -[15675, 0.65707, 0.97830, 0.12376], -[15676, 0.89141, 0.72370, 0.03952], -[15677, 0.93218, 0.79414, 0.32458], -[15678, 0.86222, 0.84050, 0.21612], -[15679, 0.86225, 0.83321, 0.19504], -[15680, 0.74127, 0.92529, 0.14631], -[15681, 0.63194, 1.00000, 0.13750], -[15682, 0.93719, 0.75991, 0.22617], -[15683, 0.75270, 0.91069, 0.13272], -[15684, 0.90771, 0.77668, 0.17793], -[15685, 0.60525, 0.98673, 0.06298], -[15686, 0.71923, 0.94492, 0.15238], -[15687, 0.89906, 0.84176, 0.38108], -[15688, 0.94063, 0.71561, 0.13365], -[15689, 0.70405, 0.93143, 0.09021], -[15690, 0.88476, 0.75639, 0.08013], -[15691, 0.96314, 0.62982, 0.04512], -[15692, 0.86277, 0.88083, 0.39487], -[15693, 0.93803, 0.77624, 0.27893], -[15694, 0.90893, 0.71270, 0.05589], -[15695, 0.84450, 0.83209, 0.14514], -[15696, 0.95093, 0.69753, 0.12491], -[15697, 0.77479, 0.87977, 0.10343], -[15698, 0.88971, 0.70000, 0.00000], -[15699, 0.73419, 0.98659, 0.36136], -[15700, 0.98075, 0.74079, 0.35500], -[15701, 0.83402, 0.79956, 0.05622], -[15702, 0.93146, 0.67833, 0.04807], -[15703, 0.95753, 0.67254, 0.09643], -[15704, 0.69686, 0.95392, 0.13055], -[15705, 0.69183, 0.97798, 0.18832], -[15706, 0.90620, 0.76680, 0.14908], -[15707, 0.78601, 0.95592, 0.47094], -[15708, 0.61029, 1.00000, 0.10000], -[15709, 0.72334, 0.89728, 0.04818], -[15710, 0.83614, 0.90297, 0.36550], -[15711, 0.65359, 1.00000, 0.17500], -[15712, 0.83283, 0.87951, 0.24375], -[15713, 0.86502, 0.77629, 0.07307], -[15714, 0.97431, 0.64473, 0.08978], -[15715, 0.72474, 0.93350, 0.13035], -[15716, 0.72101, 0.97354, 0.24366], -[15717, 0.77104, 0.96879, 0.48268], -[15718, 0.96738, 0.71847, 0.21476], -[15719, 0.71086, 0.96719, 0.19530], -[15720, 0.96264, 0.67915, 0.11827], -[15721, 0.84554, 0.87900, 0.28533], -[15722, 0.92214, 0.82627, 0.47399], -[15723, 0.97631, 0.57500, 0.00000], -[15724, 0.69474, 0.91514, 0.03771], -[15725, 0.97998, 0.67828, 0.16319], -[15726, 0.89409, 0.81790, 0.24320], -[15727, 0.85158, 0.89515, 0.41116], -[15728, 0.68974, 0.92661, 0.05267], -[15729, 0.81250, 0.93505, 0.50000], -[15730, 0.76817, 0.85954, 0.04639], -[15731, 0.95446, 0.70666, 0.14715], -[15732, 0.80311, 0.80000, 0.00000], -[15733, 0.89438, 0.77106, 0.12502], -[15734, 0.71854, 1.00000, 0.36250], -[15735, 0.89423, 0.84587, 0.35806], -[15736, 0.68740, 0.95007, 0.09974], -[15737, 0.70656, 0.94419, 0.11956], -[15738, 0.86717, 0.87571, 0.37106], -[15739, 0.77544, 0.95458, 0.34811], -[15740, 0.90063, 0.84852, 0.43266], -[15741, 0.71013, 0.89628, 0.02222], -[15742, 0.87044, 0.76216, 0.05580], -[15743, 1.00000, 0.71651, 0.35000], -[15744, 0.75137, 0.96330, 0.29163], -[15745, 0.62256, 0.96230, 0.02843], -[15746, 0.86744, 0.88504, 0.48100], -[15747, 0.91458, 0.69836, 0.03962], -[15748, 0.68389, 0.91228, 0.01399], -[15749, 0.82497, 0.86743, 0.17867], -[15750, 0.69689, 1.00000, 0.27500], -[15751, 0.93503, 0.69834, 0.08234], -[15752, 0.95466, 0.61250, 0.00000], -[15753, 0.75772, 0.93463, 0.20169], -[15754, 0.82708, 0.92140, 0.43832], -[15755, 0.97992, 0.62792, 0.07299], -[15756, 0.95444, 0.71540, 0.16213], -[15757, 0.78140, 0.96077, 0.44234], -[15758, 0.61586, 0.97551, 0.04598], -[15759, 0.77728, 0.92914, 0.23611], -[15760, 0.84006, 0.90891, 0.42699], -[15761, 0.93165, 0.71157, 0.09626], -[15762, 0.89462, 0.79465, 0.17518], -[15763, 0.97813, 0.72283, 0.25885], -[15764, 1.00000, 0.62990, 0.12500], -[15765, 0.96726, 0.64541, 0.06943], -[15766, 0.66837, 0.98039, 0.13977], -[15767, 0.85826, 0.81859, 0.13795], -[15768, 0.87353, 0.85627, 0.29618], -[15769, 0.58864, 1.00000, 0.06250], -[15770, 0.95465, 0.77833, 0.35513], -[15771, 0.88295, 0.75268, 0.06176], -[15772, 0.67121, 0.92694, 0.02183], -[15773, 1.00000, 0.65155, 0.16250], -[15774, 0.74637, 0.88334, 0.05149], -[15775, 0.77055, 0.92782, 0.21023], -[15776, 0.76250, 0.97835, 0.50000], -[15777, 0.67524, 1.00000, 0.21250], -[15778, 0.93234, 0.80813, 0.37226], -[15779, 0.73816, 0.86250, 0.00000], -[15780, 0.87093, 0.85126, 0.26415], -[15781, 1.00000, 0.56425, 0.03036], -[15782, 0.86250, 0.89175, 0.50000], -[15783, 0.74218, 0.95217, 0.21418], -[15784, 0.92500, 0.82679, 0.50000], -[15785, 1.00000, 0.69486, 0.26250], -[15786, 0.87952, 0.83184, 0.22842], -[15787, 0.78421, 0.86781, 0.08623], -[15788, 0.68424, 0.96345, 0.12202], -[15789, 0.81040, 0.92990, 0.36592], -[15790, 0.96934, 0.76071, 0.35412], -[15791, 0.94139, 0.79598, 0.35900], -[15792, 0.93268, 0.81456, 0.42044], -[15793, 0.63532, 0.94788, 0.01251], -[15794, 0.75476, 0.92660, 0.16598], -[15795, 0.60372, 0.97528, 0.02649], -[15796, 0.81641, 0.93300, 0.44614], -[15797, 0.87439, 0.86783, 0.35074], -[15798, 0.97272, 0.70010, 0.17801], -[15799, 1.00000, 0.60825, 0.08750], -[15800, 0.93081, 0.66934, 0.02481], -[15801, 0.92146, 0.75982, 0.16251], -[15802, 0.83392, 0.90513, 0.33978], -[15803, 0.78701, 0.85695, 0.06795], -[15804, 0.97955, 0.59496, 0.02361], -[15805, 0.91509, 0.72101, 0.07183], -[15806, 0.78972, 0.88967, 0.14566], -[15807, 0.94592, 0.74890, 0.20801], -[15808, 0.75463, 0.96798, 0.31388], -[15809, 0.92967, 0.72798, 0.11668], -[15810, 0.88412, 0.86883, 0.42953], -[15811, 0.96539, 0.60837, 0.01061], -[15812, 0.94332, 0.64903, 0.01974], -[15813, 0.76840, 0.95087, 0.28254], -[15814, 0.87804, 0.82137, 0.18929], -[15815, 0.80876, 0.90085, 0.22300], -[15816, 0.75986, 0.97697, 0.39673], -[15817, 0.71854, 1.00000, 0.33750], -[15818, 0.80473, 0.81904, 0.02618], -[15819, 0.93301, 0.65000, 0.00000], -[15820, 1.00000, 0.67321, 0.20000], -[15821, 0.90821, 0.79009, 0.19312], -[15822, 0.91009, 0.81164, 0.26248], -[15823, 0.94861, 0.69451, 0.09846], -[15824, 0.77307, 0.87051, 0.06633], -[15825, 0.75908, 0.91704, 0.14446], -[15826, 0.97891, 0.76346, 0.44914], -[15827, 0.92366, 0.74870, 0.13932], -[15828, 0.93689, 0.81519, 0.46104], -[15829, 0.94468, 0.80166, 0.40571], -[15830, 0.95473, 0.76580, 0.28549], -[15831, 0.92707, 0.80207, 0.29697], -[15832, 1.00000, 0.71651, 0.32500], -[15833, 0.90247, 0.80367, 0.21072], -[15834, 0.76273, 0.94314, 0.23020], -[15835, 0.84772, 0.90205, 0.39122], -[15836, 0.88863, 0.84651, 0.30507], -[15837, 0.83294, 0.84478, 0.12988], -[15838, 0.88558, 0.77726, 0.10474], -[15839, 0.88759, 0.86086, 0.37348], -[15840, 0.85265, 0.88806, 0.32882], -[15841, 0.81348, 0.93335, 0.38939], -[15842, 0.92200, 0.81454, 0.32187], -[15843, 0.85392, 0.90335, 0.48418], -[15844, 1.00000, 0.73797, 0.46964], -[15845, 0.76071, 0.97329, 0.35994], -[15846, 0.75155, 0.98265, 0.37662], -[15847, 0.78629, 0.93188, 0.25706], -[15848, 0.87206, 0.88420, 0.44159], -[15849, 0.89204, 0.81793, 0.21512], -[15850, 0.94339, 0.77460, 0.26314], -[15851, 0.88293, 0.74503, 0.04011], -[15852, 0.91483, 0.84117, 0.45674], -[15853, 0.82377, 0.91865, 0.34540], -[15854, 0.81955, 0.88377, 0.19387], -[15855, 0.73169, 0.96042, 0.20216], -[15856, 0.91658, 0.81672, 0.30147], -[15857, 1.00000, 0.58660, 0.05000], -[15858, 0.79971, 0.94991, 0.43047], -[15859, 0.64159, 0.98058, 0.08334], -[15860, 0.98391, 0.73849, 0.31692], -[15861, 0.56699, 1.00000, 0.02500], -[15862, 0.68227, 0.94436, 0.06427], -[15863, 0.73937, 1.00000, 0.47685], -[15864, 0.88888, 0.85613, 0.34451], -[15865, 0.91140, 0.84210, 0.41366], -[15866, 0.71209, 0.91672, 0.05299], -[15867, 0.95968, 0.65321, 0.05323], -[15868, 0.95416, 0.78838, 0.37577], -[15869, 0.86806, 0.73750, 0.00000], -[15870, 0.89741, 0.85712, 0.41374], -[15871, 0.88963, 0.84197, 0.28258], -[15872, 0.93169, 0.80989, 0.34597], -[15873, 0.97770, 0.75141, 0.33486], -[15874, 0.75908, 0.98515, 0.46722], -[15875, 0.98127, 0.73569, 0.29091], -[15876, 0.85447, 0.90278, 0.44771], -[15877, 0.73812, 0.96313, 0.22535], -[15878, 0.84310, 0.88391, 0.26381], -[15879, 0.76243, 0.98154, 0.44288], -[15880, 0.68614, 0.97304, 0.13891], -[15881, 0.86236, 0.79227, 0.07967], -[15882, 0.79391, 0.94772, 0.35980], -[15883, 0.69689, 1.00000, 0.25000], -[15884, 0.85432, 0.84913, 0.18789], -[15885, 0.88339, 0.73340, 0.02032], -[15886, 0.74953, 0.86861, 0.01821], -[15887, 0.75924, 0.87005, 0.03622], -[15888, 0.97307, 0.77140, 0.41841], -[15889, 0.98125, 0.70929, 0.21250], -[15890, 1.00000, 0.73816, 0.43750], -[15891, 0.98127, 0.61571, 0.04525], -[15892, 0.95838, 0.75087, 0.24214], -[15893, 0.86119, 0.89798, 0.46306], -[15894, 0.63194, 1.00000, 0.11250], -[15895, 0.65359, 1.00000, 0.15000], -[15896, 0.75981, 0.85000, 0.00000], -[15897, 0.81086, 0.84218, 0.07204], -[15898, 0.98028, 0.75705, 0.37398], -[15899, 0.84979, 0.88808, 0.30215], -[15900, 0.79609, 0.95118, 0.39244], -[15901, 0.82476, 0.78750, 0.00000], -[15902, 0.74019, 1.00000, 0.45000], -[15903, 0.92102, 0.74091, 0.10854], -[15904, 0.89346, 0.78883, 0.13952], -[15905, 0.98752, 0.75124, 0.39499], -[15906, 0.78019, 0.95477, 0.32565], -[15907, 0.96441, 0.78712, 0.46593], -[15908, 0.92321, 0.82381, 0.35818], -[15909, 0.89480, 0.84817, 0.32377], -[15910, 0.66799, 0.95853, 0.06842], -[15911, 0.95449, 0.79877, 0.45161], -[15912, 0.71854, 1.00000, 0.31250], -[15913, 0.74113, 0.97551, 0.27510], -[15914, 0.85518, 0.81729, 0.10989], -[15915, 0.74161, 0.98470, 0.32142], -[15916, 0.94815, 0.73610, 0.16718], -[15917, 1.00000, 0.69486, 0.23750], -[15918, 0.86204, 0.87476, 0.29093], -[15919, 0.80942, 0.91876, 0.26992], -[15920, 0.58750, 0.97835, 0.00000], -[15921, 0.94247, 0.73761, 0.15351], -[15922, 0.75683, 0.94779, 0.21477], -[15923, 1.00000, 0.55000, 0.00000], -[15924, 0.55000, 1.00000, 0.00000], -[15925, 0.91250, 0.84845, 0.50000], -[15926, 1.00000, 0.73816, 0.41250], -[15927, 0.74532, 0.96692, 0.25052], -[15928, 0.93307, 0.79353, 0.27103], -[15929, 0.94750, 0.66375, 0.03687], -[15930, 0.92038, 0.78942, 0.21258], -[15931, 0.83931, 0.87237, 0.20408], -[15932, 0.61029, 1.00000, 0.07500], -[15933, 0.92500, 0.77581, 0.19061], -[15934, 0.91136, 0.68750, 0.00000], -[15935, 0.82942, 0.92995, 0.47587], -[15936, 0.87977, 0.86542, 0.32562], -[15937, 1.00000, 0.71651, 0.30000], -[15938, 0.65155, 0.93750, 0.00000], -[15939, 0.93905, 0.75783, 0.18800], -[15940, 0.74019, 1.00000, 0.42500], -[15941, 0.67524, 1.00000, 0.18750], -[15942, 0.79889, 0.92406, 0.25179], -[15943, 0.80967, 0.93550, 0.34781], -[15944, 0.86436, 0.87844, 0.31256], -[15945, 0.91398, 0.75925, 0.12301], -[15946, 0.94196, 0.77409, 0.24022], -[15947, 0.95491, 0.80098, 0.47593], -[15948, 0.75277, 0.91501, 0.11249], -[15949, 0.74462, 0.89967, 0.06374], -[15950, 0.75865, 0.95624, 0.24623], -[15951, 0.85637, 0.76802, 0.01926], -[15952, 0.85709, 0.89632, 0.37213], -[15953, 0.80453, 0.89904, 0.18559], -[15954, 0.80179, 0.95390, 0.45991], -[15955, 0.91521, 0.73949, 0.08773], -[15956, 0.89987, 0.73901, 0.05440], -[15957, 0.72668, 0.96121, 0.17976], -[15958, 0.75341, 0.98182, 0.34826], -[15959, 0.92718, 0.74607, 0.12742], -[15960, 0.95123, 0.80313, 0.42767], -[15961, 0.80074, 0.89477, 0.16335], -[15962, 0.80000, 0.95670, 0.50000], -[15963, 0.97818, 0.76763, 0.40362], -[15964, 0.90727, 0.78464, 0.15803], -[15965, 0.97075, 0.72020, 0.19211], -[15966, 0.62500, 0.95670, 0.00000], -[15967, 1.00000, 0.65155, 0.13750], -[15968, 0.93395, 0.82057, 0.39831], -[15969, 0.88382, 0.87309, 0.38665], -[15970, 0.90127, 0.86070, 0.44246], -[15971, 0.77558, 0.92586, 0.18736], -[15972, 1.00000, 0.62990, 0.10000], -[15973, 0.85000, 0.91340, 0.50000], -[15974, 0.86287, 0.86526, 0.24783], -[15975, 0.77077, 0.92241, 0.16548], -[15976, 0.84145, 0.90254, 0.31499], -[15977, 0.73589, 0.92834, 0.10809], -[15978, 0.98500, 0.58718, 0.00772], -[15979, 0.97113, 0.69322, 0.13431], -[15980, 1.00000, 0.73816, 0.38750], -[15981, 0.82492, 0.93370, 0.42711], -[15982, 0.74019, 1.00000, 0.40000], -[15983, 0.90736, 0.82799, 0.27838], -[15984, 0.80176, 0.93248, 0.28624], -[15985, 0.72108, 0.97765, 0.21300], -[15986, 0.83866, 0.89933, 0.28553], -[15987, 0.97554, 0.75045, 0.29148], -[15988, 0.79748, 0.84589, 0.04517], -[15989, 0.86264, 0.78305, 0.05159], -[15990, 0.73364, 0.89393, 0.02983], -[15991, 0.76041, 0.93862, 0.18487], -[15992, 0.95379, 0.78497, 0.31869], -[15993, 0.94643, 0.71612, 0.11235], -[15994, 0.67321, 0.92500, 0.00000], -[15995, 1.00000, 0.67321, 0.17500], -[15996, 0.78682, 0.94231, 0.27183], -[15997, 0.95246, 0.67464, 0.05636], -[15998, 0.93145, 0.71094, 0.06842], -[15999, 0.89070, 0.83912, 0.25129], -[16000, 0.91055, 0.83651, 0.32525], -[16001, 0.77485, 0.94572, 0.24549], -[16002, 0.78906, 0.91143, 0.17399], -[16003, 0.87633, 0.82599, 0.16923], -[16004, 0.98155, 0.65895, 0.09753], -[16005, 0.67021, 0.97796, 0.10748], -[16006, 0.69218, 0.98208, 0.15914], -[16007, 0.78882, 0.92685, 0.21980], -[16008, 0.96436, 0.76954, 0.30589], -[16009, 0.63819, 0.97131, 0.04264], -[16010, 0.76906, 0.98125, 0.42500], -[16011, 0.91444, 0.84104, 0.37057], -[16012, 0.71742, 0.96414, 0.15931], -[16013, 0.83037, 0.90009, 0.25364], -[16014, 0.97346, 0.70428, 0.15827], -[16015, 0.83485, 0.79165, 0.01334], -[16016, 0.80094, 0.87676, 0.11228], -[16017, 0.97605, 0.75757, 0.31561], -[16018, 0.96694, 0.78841, 0.43568], -[16019, 0.83254, 0.92343, 0.37744], -[16020, 0.88606, 0.87597, 0.40779], -[16021, 0.87808, 0.81570, 0.14704], -[16022, 0.86364, 0.87432, 0.27492], -[16023, 0.95102, 0.79411, 0.33885], -[16024, 0.71215, 0.94433, 0.09729], -[16025, 0.83902, 0.81992, 0.06984], -[16026, 0.69689, 1.00000, 0.22500], -[16027, 1.00000, 0.60825, 0.06250], -[16028, 0.71854, 1.00000, 0.28750], -[16029, 0.87647, 0.79834, 0.10503], -[16030, 0.80737, 0.88077, 0.13396], -[16031, 0.78146, 0.83750, 0.00000], -[16032, 0.91202, 0.84093, 0.34774], -[16033, 0.98019, 0.74135, 0.27219], -[16034, 0.66366, 0.97436, 0.08448], -[16035, 0.81403, 0.90146, 0.20467], -[16036, 1.00000, 0.75000, 0.50000], -[16037, 0.75000, 1.00000, 0.50000], -[16038, 0.82324, 0.84894, 0.09444], -[16039, 0.97631, 0.60000, 0.00000], -[16040, 0.92088, 0.83910, 0.39465], -[16041, 0.95557, 0.68608, 0.07636], -[16042, 0.74019, 1.00000, 0.37500], -[16043, 0.98125, 0.70929, 0.18750], -[16044, 0.82855, 0.91984, 0.32396], -[16045, 0.81275, 0.95015, 0.47974], -[16046, 0.84006, 0.83961, 0.10867], -[16047, 1.00000, 0.73816, 0.36250], -[16048, 1.00000, 0.71651, 0.27500], -[16049, 0.97242, 0.62474, 0.02212], -[16050, 0.98579, 0.72354, 0.23722], -[16051, 0.92773, 0.70577, 0.04659], -[16052, 0.78519, 0.91036, 0.15489], -[16053, 0.74977, 0.92857, 0.12580], -[16054, 0.97500, 0.78349, 0.50000], -[16055, 0.88636, 0.88243, 0.48506], -[16056, 0.93454, 0.82992, 0.44894], -[16057, 0.74458, 0.94682, 0.16215], -[16058, 0.82430, 0.80914, 0.01938], -[16059, 0.94287, 0.69422, 0.05919], -[16060, 0.73495, 0.98425, 0.26239], -[16061, 0.69486, 0.91250, 0.00000], -[16062, 1.00000, 0.69486, 0.21250], -[16063, 0.98099, 0.77634, 0.47582], -[16064, 0.65735, 0.94971, 0.01875], -[16065, 0.92492, 0.84249, 0.47723], -[16066, 0.93068, 0.79269, 0.23284], -[16067, 0.77490, 0.97521, 0.38002], -[16068, 0.78833, 0.96930, 0.42910], -[16069, 0.81593, 0.91289, 0.24120], -[16070, 0.97126, 0.78148, 0.38947], -[16071, 0.96719, 0.75941, 0.26721], -[16072, 0.98466, 0.68885, 0.15030], -[16073, 0.93514, 0.75347, 0.14749], -[16074, 0.81771, 0.92788, 0.30789], -[16075, 0.87127, 0.76990, 0.03663], -[16076, 0.58831, 1.00000, 0.03036], -[16077, 0.78858, 0.94984, 0.29345], -[16078, 0.72141, 0.92834, 0.07046], -[16079, 0.71553, 0.91520, 0.03396], -[16080, 0.84641, 0.77500, 0.00000], -[16081, 0.90000, 0.87010, 0.50000], -[16082, 0.82314, 0.85782, 0.10794], -[16083, 0.88971, 0.72500, 0.00000], -[16084, 0.78542, 0.85321, 0.02845], -[16085, 0.95797, 0.79915, 0.39569], -[16086, 0.84483, 0.88176, 0.22430], -[16087, 0.86343, 0.85544, 0.19988], -[16088, 0.90120, 0.81160, 0.18920], -[16089, 0.93956, 0.77788, 0.21770], -[16090, 0.95466, 0.63750, 0.00000], -[16091, 0.65359, 1.00000, 0.12500], -[16092, 0.70926, 0.98652, 0.19746], -[16093, 0.75406, 0.95369, 0.20042], -[16094, 0.86595, 0.90157, 0.42788], -[16095, 0.80610, 0.86228, 0.08206], -[16096, 0.77141, 0.95763, 0.26320], -[16097, 0.96038, 0.73849, 0.18288], -[16098, 0.76831, 0.91054, 0.11393], -[16099, 0.88587, 0.88450, 0.46223], -[16100, 0.82764, 0.93540, 0.40734], -[16101, 0.88308, 0.83810, 0.20612], -[16102, 0.83022, 0.89827, 0.23075], -[16103, 0.75823, 0.91058, 0.09428], -[16104, 0.98898, 0.64285, 0.07890], -[16105, 0.81567, 0.93548, 0.33191], -[16106, 0.77653, 0.88857, 0.08009], -[16107, 0.91091, 0.85928, 0.47047], -[16108, 0.79556, 0.95995, 0.37916], -[16109, 0.95367, 0.78532, 0.29309], -[16110, 0.96893, 0.79393, 0.48576], -[16111, 0.63194, 1.00000, 0.08750], -[16112, 0.85642, 0.81409, 0.08364], -[16113, 0.71124, 0.97944, 0.17688], -[16114, 0.67524, 1.00000, 0.16250], -[16115, 0.79834, 0.96445, 0.44919], -[16116, 0.94460, 0.82311, 0.48117], -[16117, 0.70304, 0.91681, 0.01478], -[16118, 0.74019, 1.00000, 0.35000], -[16119, 0.90063, 0.87065, 0.46315], -[16120, 0.96172, 0.65186, 0.03005], -[16121, 0.68564, 0.93526, 0.02461], -[16122, 0.74093, 0.91811, 0.07691], -[16123, 0.84018, 0.80389, 0.03226], -[16124, 0.97678, 0.66256, 0.07826], -[16125, 0.79269, 0.89501, 0.12352], -[16126, 0.91828, 0.72740, 0.05414], -[16127, 1.00000, 0.73816, 0.33750], -[16128, 0.64991, 0.97914, 0.06389], -[16129, 1.00000, 0.58655, 0.02315], -[16130, 0.79351, 0.97037, 0.48714], -[16131, 0.82839, 0.82053, 0.03953], -[16132, 0.96971, 0.72250, 0.16929], -[16133, 0.76869, 0.97365, 0.31832], -[16134, 0.79888, 0.83799, 0.01880], -[16135, 0.92646, 0.81526, 0.27818], -[16136, 0.82130, 0.89023, 0.17553], -[16137, 0.71854, 1.00000, 0.26250], -[16138, 0.92413, 0.84558, 0.43904], -[16139, 0.85943, 0.86737, 0.21396], -[16140, 0.80948, 0.83867, 0.03710], -[16141, 0.95916, 0.71991, 0.13280], -[16142, 0.82056, 0.93981, 0.37110], -[16143, 0.94698, 0.73321, 0.12732], -[16144, 0.71651, 0.90000, 0.00000], -[16145, 0.97393, 0.67477, 0.08806], -[16146, 0.82438, 0.94455, 0.45738], -[16147, 0.88294, 0.86406, 0.28196], -[16148, 0.85605, 0.80401, 0.05902], -[16149, 0.70447, 0.94072, 0.06115], -[16150, 0.84523, 0.92207, 0.40134], -[16151, 0.77637, 0.91667, 0.13750], -[16152, 0.97717, 0.73837, 0.22698], -[16153, 1.00000, 0.65155, 0.11250], -[16154, 0.90415, 0.72500, 0.01875], -[16155, 0.83124, 0.86683, 0.13606], -[16156, 0.61029, 1.00000, 0.05000], -[16157, 0.88298, 0.85457, 0.24488], -[16158, 0.93489, 0.68716, 0.02164], -[16159, 0.83744, 0.92368, 0.35566], -[16160, 0.97648, 0.74757, 0.24911], -[16161, 0.80311, 0.82500, 0.00000], -[16162, 0.85498, 0.83956, 0.12613], -[16163, 0.69689, 1.00000, 0.20000], -[16164, 0.94560, 0.82318, 0.43735], -[16165, 1.00000, 0.67321, 0.15000], -[16166, 0.83750, 0.93505, 0.50000], -[16167, 0.80168, 0.96198, 0.41191], -[16168, 1.00000, 0.71651, 0.25000], -[16169, 0.93301, 0.67500, 0.00000], -[16170, 0.93357, 0.83043, 0.37758], -[16171, 0.72027, 0.95979, 0.13079], -[16172, 0.93215, 0.83674, 0.41452], -[16173, 0.95020, 0.81086, 0.37325], -[16174, 0.85627, 0.85470, 0.16393], -[16175, 0.76189, 0.90453, 0.07807], -[16176, 0.91919, 0.79219, 0.17650], -[16177, 0.78529, 0.97938, 0.46417], -[16178, 0.85449, 0.90855, 0.35288], -[16179, 0.96458, 0.80429, 0.50000], -[16180, 0.78750, 0.97835, 0.50000], -[16181, 1.00000, 0.62990, 0.07500], -[16182, 0.73873, 0.94984, 0.14015], -[16183, 0.90322, 0.75909, 0.06910], -[16184, 0.65908, 0.96374, 0.03683], -[16185, 0.74968, 0.96722, 0.21667], -[16186, 0.97419, 0.78176, 0.36670], -[16187, 0.85008, 0.91006, 0.33488], -[16188, 0.85475, 0.86633, 0.18857], -[16189, 0.95802, 0.77815, 0.26586], -[16190, 0.90582, 0.76576, 0.08618], -[16191, 0.92041, 0.75627, 0.10116], -[16192, 0.82421, 0.86877, 0.12037], -[16193, 0.78997, 0.86616, 0.04843], -[16194, 0.78241, 0.97788, 0.40105], -[16195, 0.68504, 0.96650, 0.08158], -[16196, 0.74019, 1.00000, 0.32500], -[16197, 0.87395, 0.89780, 0.40669], -[16198, 0.75742, 0.93699, 0.14367], -[16199, 0.79728, 0.95853, 0.34363], -[16200, 0.95787, 0.73413, 0.15003], -[16201, 0.73638, 0.98267, 0.23344], -[16202, 0.87311, 0.89219, 0.35621], -[16203, 0.84937, 0.85440, 0.14272], -[16204, 1.00000, 0.76063, 0.47685], -[16205, 0.74580, 0.90255, 0.04325], -[16206, 0.77631, 0.87907, 0.04830], -[16207, 0.91696, 0.81996, 0.24221], -[16208, 0.90828, 0.77484, 0.10713], -[16209, 0.77321, 0.96949, 0.29508], -[16210, 1.00000, 0.75981, 0.45000], -[16211, 0.96291, 0.69856, 0.09414], -[16212, 0.80464, 0.92079, 0.20911], -[16213, 0.81772, 0.89041, 0.15581], -[16214, 0.89749, 0.79243, 0.11720], -[16215, 0.83387, 0.89425, 0.20844], -[16216, 1.00000, 0.73816, 0.31250], -[16217, 0.88915, 0.87825, 0.36492], -[16218, 0.91496, 0.74449, 0.06553], -[16219, 0.90347, 0.86548, 0.37753], -[16220, 1.00000, 0.69486, 0.18750], -[16221, 0.83405, 0.91946, 0.30136], -[16222, 0.64341, 0.96782, 0.02055], -[16223, 1.00000, 0.57500, 0.00000], -[16224, 0.57500, 1.00000, 0.00000], -[16225, 0.89511, 0.81579, 0.16245], -[16226, 0.96768, 0.76518, 0.25754], -[16227, 0.90899, 0.84400, 0.29476], -[16228, 0.87252, 0.79072, 0.05913], -[16229, 0.96995, 0.70012, 0.11248], -[16230, 0.76203, 1.00000, 0.46964], -[16231, 0.89382, 0.85295, 0.26507], -[16232, 0.73492, 0.91844, 0.05475], -[16233, 0.91646, 0.85437, 0.38981], -[16234, 0.87045, 0.81327, 0.09636], -[16235, 0.84410, 0.93104, 0.44779], -[16236, 0.68372, 0.98472, 0.11929], -[16237, 0.77695, 0.97630, 0.34080], -[16238, 0.82395, 0.92610, 0.28639], -[16239, 0.61250, 0.97835, 0.00000], -[16240, 0.82293, 0.92097, 0.26125], -[16241, 0.96923, 0.79732, 0.41463], -[16242, 0.70955, 0.97608, 0.14469], -[16243, 0.91293, 0.86207, 0.42362], -[16244, 0.73816, 0.88750, 0.00000], -[16245, 0.69235, 0.94611, 0.04371], -[16246, 0.93260, 0.82913, 0.34021], -[16247, 0.89479, 0.88264, 0.44446], -[16248, 0.88750, 0.89175, 0.50000], -[16249, 1.00000, 0.75981, 0.42500], -[16250, 0.87801, 0.76077, 0.01667], -[16251, 0.89105, 0.80825, 0.13111], -[16252, 0.80753, 0.93586, 0.26427], -[16253, 0.92148, 0.81050, 0.22164], -[16254, 0.98355, 0.68342, 0.11389], -[16255, 0.70321, 0.97334, 0.12355], -[16256, 0.98184, 0.77072, 0.33963], -[16257, 0.97441, 0.77671, 0.32385], -[16258, 0.91408, 0.72757, 0.03207], -[16259, 0.76709, 0.87548, 0.02149], -[16260, 0.94449, 0.81344, 0.32642], -[16261, 1.00000, 0.60688, 0.03542], -[16262, 0.76184, 1.00000, 0.43750], -[16263, 0.85986, 0.79630, 0.04043], -[16264, 0.94450, 0.79414, 0.25113], -[16265, 0.98440, 0.63842, 0.04381], -[16266, 0.97319, 0.74088, 0.20179], -[16267, 0.86806, 0.76250, 0.00000], -[16268, 0.93223, 0.81044, 0.25648], -[16269, 0.71854, 1.00000, 0.23750], -[16270, 0.88624, 0.89123, 0.42495], -[16271, 0.91453, 0.78162, 0.12817], -[16272, 0.78170, 0.94774, 0.22339], -[16273, 0.85875, 0.91693, 0.41240], -[16274, 0.85070, 0.91993, 0.37335], -[16275, 0.79345, 0.96005, 0.31344], -[16276, 0.95000, 0.82679, 0.50000], -[16277, 0.75503, 0.98592, 0.29012], -[16278, 0.70633, 0.95898, 0.09060], -[16279, 0.96826, 0.64168, 0.01313], -[16280, 0.73538, 0.93478, 0.08541], -[16281, 0.67740, 0.96214, 0.05058], -[16282, 0.90587, 0.87505, 0.48428], -[16283, 0.96286, 0.79962, 0.35773], -[16284, 0.87908, 0.89395, 0.37831], -[16285, 0.82046, 0.95262, 0.42062], -[16286, 0.82097, 0.95368, 0.44111], -[16287, 0.83943, 0.83810, 0.07584], -[16288, 0.86077, 0.89386, 0.28303], -[16289, 0.95316, 0.70527, 0.07442], -[16290, 0.93604, 0.74020, 0.09618], -[16291, 0.65359, 1.00000, 0.10000], -[16292, 1.00000, 0.75981, 0.40000], -[16293, 0.67524, 1.00000, 0.13750], -[16294, 0.75372, 0.97276, 0.22968], -[16295, 0.79508, 0.87682, 0.06812], -[16296, 0.74019, 1.00000, 0.30000], -[16297, 0.79715, 0.94036, 0.23868], -[16298, 0.98594, 0.61529, 0.01277], -[16299, 0.97069, 0.75156, 0.21544], -[16300, 0.76184, 1.00000, 0.41250], -[16301, 0.69441, 0.97351, 0.10234], -[16302, 0.91136, 0.71250, 0.00000], -[16303, 0.74605, 0.96757, 0.19104], -[16304, 0.62859, 0.98436, 0.02636], -[16305, 0.95492, 0.76593, 0.19975], -[16306, 0.84279, 0.87175, 0.15584], -[16307, 0.94928, 0.68928, 0.03892], -[16308, 0.95315, 0.67355, 0.02386], -[16309, 0.76943, 0.97222, 0.27276], -[16310, 1.00000, 0.71651, 0.22500], -[16311, 0.85148, 0.92908, 0.47060], -[16312, 0.78631, 0.98384, 0.44582], -[16313, 0.82839, 0.93884, 0.35311], -[16314, 0.75102, 0.89015, 0.01744], -[16315, 0.84974, 0.89499, 0.24241], -[16316, 0.86870, 0.84270, 0.14679], -[16317, 0.82707, 0.84277, 0.05793], -[16318, 0.86592, 0.90974, 0.38851], -[16319, 0.85673, 0.78888, 0.01672], -[16320, 0.93631, 0.75407, 0.11974], -[16321, 1.00000, 0.73816, 0.28750], -[16322, 0.81818, 0.95409, 0.39802], -[16323, 0.89356, 0.84340, 0.21651], -[16324, 0.93886, 0.84110, 0.46481], -[16325, 0.70871, 0.93322, 0.03405], -[16326, 0.82476, 0.81250, 0.00000], -[16327, 0.73603, 0.94987, 0.11735], -[16328, 0.83445, 0.94336, 0.43514], -[16329, 0.63194, 1.00000, 0.06250], -[16330, 0.86986, 0.82966, 0.11797], -[16331, 0.88029, 0.84831, 0.18947], -[16332, 0.89842, 0.76062, 0.04677], -[16333, 0.93209, 0.73629, 0.07548], -[16334, 0.69689, 1.00000, 0.17500], -[16335, 0.88670, 0.89166, 0.39985], -[16336, 0.78696, 0.97565, 0.35806], -[16337, 0.80956, 0.86129, 0.05938], -[16338, 0.76978, 0.92772, 0.12813], -[16339, 0.88901, 0.79027, 0.07948], -[16340, 0.91453, 0.85309, 0.33365], -[16341, 0.93964, 0.75853, 0.13364], -[16342, 0.92169, 0.80778, 0.19884], -[16343, 0.75981, 0.87500, 0.00000], -[16344, 1.00000, 0.75981, 0.37500], -[16345, 0.72529, 0.91124, 0.01360], -[16346, 0.76184, 1.00000, 0.38750], -[16347, 0.87374, 0.91003, 0.45964], -[16348, 0.87927, 0.86110, 0.21957], -[16349, 0.88112, 0.87148, 0.26031], -[16350, 0.95162, 0.82474, 0.41238], -[16351, 0.94959, 0.81686, 0.34318], -[16352, 0.97631, 0.62500, 0.00000], -[16353, 1.00000, 0.67321, 0.12500], -[16354, 0.77543, 0.94546, 0.18555], -[16355, 0.84117, 0.88818, 0.18753], -[16356, 0.73169, 0.98015, 0.18658], -[16357, 0.64995, 0.96018, 0.00000], -[16358, 0.97572, 0.78622, 0.34422], -[16359, 1.00000, 0.65155, 0.08750], -[16360, 0.94730, 0.80585, 0.28032], -[16361, 0.78500, 0.88951, 0.06682], -[16362, 0.94147, 0.77108, 0.16208], -[16363, 0.81419, 0.95618, 0.36602], -[16364, 0.96430, 0.77548, 0.24714], -[16365, 0.87925, 0.89031, 0.32702], -[16366, 0.97332, 0.80449, 0.46585], -[16367, 0.92457, 0.85965, 0.45524], -[16368, 0.89366, 0.87205, 0.30829], -[16369, 0.90974, 0.85597, 0.31143], -[16370, 0.82500, 0.95670, 0.50000], -[16371, 0.80302, 0.88414, 0.08839], -[16372, 0.76860, 0.95793, 0.20405], -[16373, 0.95872, 0.82200, 0.46309], -[16374, 0.92580, 0.71250, 0.01875], -[16375, 0.85964, 0.92587, 0.48467], -[16376, 1.00000, 0.69486, 0.16250], -[16377, 0.85535, 0.83337, 0.08671], -[16378, 0.95935, 0.73703, 0.13470], -[16379, 0.78311, 0.93521, 0.16935], -[16380, 0.83435, 0.94250, 0.38657], -[16381, 0.96452, 0.74268, 0.16012], -[16382, 0.97355, 0.67831, 0.06438], -[16383, 0.84734, 0.93437, 0.41776], -[16384, 0.95330, 0.82230, 0.38607], -[16385, 0.86409, 0.90448, 0.31760], -[16386, 0.86466, 0.92001, 0.43586], -[16387, 0.74019, 1.00000, 0.27500], -[16388, 0.92281, 0.83074, 0.26162], -[16389, 0.74519, 0.97904, 0.20890], -[16390, 0.93750, 0.84845, 0.50000], -[16391, 0.71854, 1.00000, 0.21250], -[16392, 1.00000, 0.62990, 0.05000], -[16393, 0.76184, 1.00000, 0.36250], -[16394, 0.77842, 0.90958, 0.09249], -[16395, 0.85466, 0.91010, 0.29800], -[16396, 0.91015, 0.87263, 0.40136], -[16397, 0.82238, 0.83202, 0.01931], -[16398, 1.00000, 0.75981, 0.35000], -[16399, 0.64452, 0.99158, 0.05147], -[16400, 0.67930, 0.95702, 0.02827], -[16401, 0.78315, 0.91525, 0.11419], -[16402, 0.87500, 0.91340, 0.50000], -[16403, 0.66103, 0.98099, 0.05186], -[16404, 0.83892, 0.94661, 0.48310], -[16405, 0.81257, 0.91909, 0.19147], -[16406, 0.95466, 0.66250, 0.00000], -[16407, 0.90476, 0.88104, 0.42586], -[16408, 0.96261, 0.77296, 0.22374], -[16409, 0.76660, 0.90309, 0.05599], -[16410, 0.81031, 0.95092, 0.30080], -[16411, 0.61088, 1.00000, 0.02315], -[16412, 1.00000, 0.77500, 0.50000], -[16413, 0.77500, 1.00000, 0.50000], -[16414, 0.75815, 0.93440, 0.10916], -[16415, 0.93458, 0.77219, 0.13802], -[16416, 0.95608, 0.72137, 0.09210], -[16417, 0.72309, 0.98108, 0.15988], -[16418, 0.88522, 0.81626, 0.11117], -[16419, 0.92486, 0.78840, 0.14752], -[16420, 1.00000, 0.73816, 0.26250], -[16421, 0.96646, 0.81670, 0.48405], -[16422, 0.89985, 0.79196, 0.09437], -[16423, 0.84703, 0.86040, 0.12068], -[16424, 0.96041, 0.69483, 0.05674], -[16425, 0.78027, 0.93249, 0.14878], -[16426, 0.76727, 0.96831, 0.22531], -[16427, 0.79041, 0.97239, 0.32222], -[16428, 0.80892, 0.90341, 0.13743], -[16429, 0.95522, 0.80649, 0.30186], -[16430, 0.72845, 0.97374, 0.14856], -[16431, 0.79152, 0.91833, 0.13600], -[16432, 0.82715, 0.85826, 0.07382], -[16433, 0.89417, 0.88179, 0.34053], -[16434, 0.95063, 0.82394, 0.35852], -[16435, 0.85925, 0.84312, 0.10819], -[16436, 0.88562, 0.90308, 0.44396], -[16437, 0.81459, 0.93027, 0.22768], -[16438, 0.80323, 0.91620, 0.15563], -[16439, 1.00000, 0.71651, 0.20000], -[16440, 0.97283, 0.80151, 0.37834], -[16441, 0.79202, 0.94146, 0.19943], -[16442, 0.88971, 0.75000, 0.00000], -[16443, 0.98204, 0.79832, 0.44986], -[16444, 0.81117, 0.97032, 0.43109], -[16445, 0.76080, 0.92586, 0.08983], -[16446, 0.69719, 0.96170, 0.06024], -[16447, 0.94084, 0.82277, 0.29443], -[16448, 0.78146, 0.86250, 0.00000], -[16449, 0.91228, 0.83060, 0.21287], -[16450, 0.93409, 0.84401, 0.35907], -[16451, 0.67055, 0.95144, 0.00000], -[16452, 0.87573, 0.80936, 0.07215], -[16453, 0.97872, 0.72160, 0.14429], -[16454, 0.81691, 0.95206, 0.32277], -[16455, 0.98423, 0.76502, 0.27345], -[16456, 0.91209, 0.84902, 0.27047], -[16457, 0.67553, 0.98004, 0.06566], -[16458, 0.77857, 0.99025, 0.36220], -[16459, 0.82440, 0.87176, 0.09219], -[16460, 0.67524, 1.00000, 0.11250], -[16461, 0.84641, 0.80000, 0.00000], -[16462, 0.76184, 1.00000, 0.33750], -[16463, 0.89556, 0.78162, 0.05968], -[16464, 0.97225, 0.81061, 0.43312], -[16465, 0.81781, 0.93551, 0.24899], -[16466, 0.81907, 0.96741, 0.48357], -[16467, 0.97633, 0.77837, 0.28084], -[16468, 0.79798, 0.95422, 0.25531], -[16469, 0.91535, 0.74817, 0.04214], -[16470, 0.90620, 0.74619, 0.02118], -[16471, 0.94041, 0.79914, 0.20950], -[16472, 0.72438, 0.93828, 0.04998], -[16473, 0.73236, 0.92211, 0.02992], -[16474, 0.80557, 0.95377, 0.27851], -[16475, 0.85714, 0.87385, 0.16926], -[16476, 0.98723, 0.77144, 0.30516], -[16477, 0.98272, 0.66152, 0.04794], -[16478, 0.65359, 1.00000, 0.07500], -[16479, 0.76800, 0.89483, 0.03382], -[16480, 1.00000, 0.75981, 0.32500], -[16481, 0.77094, 0.94905, 0.16401], -[16482, 0.89562, 0.83609, 0.17318], -[16483, 0.69689, 1.00000, 0.15000], -[16484, 0.81529, 0.97067, 0.46167], -[16485, 0.85582, 0.88829, 0.20522], -[16486, 0.93995, 0.79173, 0.18630], -[16487, 0.87352, 0.78324, 0.01808], -[16488, 0.82833, 0.90813, 0.18695], -[16489, 0.79589, 0.86250, 0.01875], -[16490, 0.94375, 0.84110, 0.39518], -[16491, 0.92766, 0.83768, 0.28297], -[16492, 0.94732, 0.71583, 0.05305], -[16493, 0.92918, 0.75496, 0.07998], -[16494, 1.00000, 0.60000, 0.00000], -[16495, 0.60000, 1.00000, 0.00000], -[16496, 0.84735, 0.88443, 0.16844], -[16497, 1.00000, 0.78038, 0.46458], -[16498, 0.98321, 0.73639, 0.18163], -[16499, 0.95813, 0.76603, 0.17515], -[16500, 0.77604, 0.97404, 0.25628], -[16501, 0.74019, 1.00000, 0.25000], -[16502, 0.97335, 0.66448, 0.02934], -[16503, 0.93301, 0.70000, 0.00000], -[16504, 0.81473, 0.89449, 0.11708], -[16505, 0.85113, 0.92333, 0.31617], -[16506, 0.93229, 0.86091, 0.47624], -[16507, 0.88992, 0.83498, 0.15096], -[16508, 0.98054, 0.79972, 0.39989], -[16509, 0.93224, 0.85648, 0.40771], -[16510, 0.91142, 0.86970, 0.34401], -[16511, 0.93014, 0.77275, 0.11386], -[16512, 0.87236, 0.91259, 0.36672], -[16513, 0.93132, 0.84052, 0.30546], -[16514, 0.83431, 0.91401, 0.21677], -[16515, 0.80748, 0.97378, 0.39309], -[16516, 0.69486, 0.93750, 0.00000], -[16517, 0.98771, 0.79444, 0.42795], -[16518, 0.75223, 0.92211, 0.05738], -[16519, 0.78849, 0.97008, 0.27797], -[16520, 0.91771, 0.87700, 0.46633], -[16521, 0.74695, 0.90661, 0.01765], -[16522, 0.92500, 0.87010, 0.50000], -[16523, 0.90212, 0.81843, 0.14074], -[16524, 0.88077, 0.85122, 0.16437], -[16525, 0.95603, 0.75925, 0.14970], -[16526, 1.00000, 0.67321, 0.10000], -[16527, 0.90479, 0.87379, 0.32364], -[16528, 0.83990, 0.82480, 0.02281], -[16529, 0.63750, 0.97835, 0.00000], -[16530, 0.90087, 0.88782, 0.38220], -[16531, 0.63078, 1.00000, 0.03542], -[16532, 1.00000, 0.73816, 0.23750], -[16533, 0.95671, 0.79075, 0.22920], -[16534, 0.71854, 1.00000, 0.18750], -[16535, 0.84271, 0.92471, 0.27870], -[16536, 1.00000, 0.69486, 0.13750], -[16537, 0.96336, 0.73166, 0.11159], -[16538, 0.80638, 0.97172, 0.35929], -[16539, 0.78349, 1.00000, 0.47500], -[16540, 1.00000, 0.78146, 0.43750], -[16541, 0.84332, 0.93584, 0.33377], -[16542, 0.86639, 0.88879, 0.22787], -[16543, 0.98814, 0.70573, 0.12530], -[16544, 0.85575, 0.81983, 0.04121], -[16545, 0.68508, 0.95014, 0.00714], -[16546, 0.88288, 0.88659, 0.27751], -[16547, 0.83516, 0.93943, 0.31261], -[16548, 0.84721, 0.83632, 0.05509], -[16549, 0.98637, 0.63872, 0.01582], -[16550, 0.76184, 1.00000, 0.31250], -[16551, 0.83912, 0.89053, 0.15554], -[16552, 0.91693, 0.87895, 0.44927], -[16553, 1.00000, 0.65155, 0.06250], -[16554, 0.94699, 0.84793, 0.48605], -[16555, 0.97932, 0.76242, 0.22455], -[16556, 0.78349, 1.00000, 0.45000], -[16557, 0.88293, 0.87646, 0.23796], -[16558, 0.91788, 0.80910, 0.15460], -[16559, 0.77190, 0.99105, 0.30394], -[16560, 0.87571, 0.90817, 0.34170], -[16561, 0.83290, 0.96023, 0.46715], -[16562, 0.94694, 0.81298, 0.25665], -[16563, 0.82096, 0.95812, 0.34208], -[16564, 0.94162, 0.85132, 0.42543], -[16565, 0.87117, 0.89201, 0.25010], -[16566, 1.00000, 0.75981, 0.30000], -[16567, 0.84339, 0.85903, 0.09004], -[16568, 0.81250, 0.97835, 0.50000], -[16569, 0.80311, 0.85000, 0.00000], -[16570, 0.87390, 0.90154, 0.29746], -[16571, 0.98313, 0.80683, 0.48965], -[16572, 0.86871, 0.92783, 0.45333], -[16573, 0.85036, 0.90383, 0.22122], -[16574, 0.72419, 0.95398, 0.07164], -[16575, 0.86250, 0.93505, 0.50000], -[16576, 0.82784, 0.89391, 0.13404], -[16577, 1.00000, 0.78146, 0.41250], -[16578, 0.89216, 0.77459, 0.02833], -[16579, 0.81766, 0.93086, 0.21130], -[16580, 0.91301, 0.84524, 0.23460], -[16581, 0.91573, 0.82587, 0.18705], -[16582, 0.83786, 0.90024, 0.17420], -[16583, 0.74164, 0.93780, 0.06512], -[16584, 0.92846, 0.86740, 0.43407], -[16585, 0.71651, 0.92500, 0.00000], -[16586, 1.00000, 0.71651, 0.17500], -[16587, 0.73021, 0.98758, 0.16718], -[16588, 0.78349, 1.00000, 0.42500], -[16589, 0.97615, 0.79300, 0.30484], -[16590, 0.90350, 0.84322, 0.19581], -[16591, 0.90824, 0.86693, 0.29131], -[16592, 0.66570, 0.97092, 0.01605], -[16593, 0.94384, 0.71453, 0.03228], -[16594, 0.65474, 0.98530, 0.03020], -[16595, 0.87641, 0.87274, 0.19923], -[16596, 0.93522, 0.85525, 0.38091], -[16597, 0.86375, 0.82692, 0.06347], -[16598, 0.76952, 0.96279, 0.18171], -[16599, 0.75689, 0.95296, 0.12644], -[16600, 0.79357, 0.98768, 0.37545], -[16601, 0.72522, 0.97171, 0.11180], -[16602, 0.96637, 0.80959, 0.32169], -[16603, 0.80255, 0.98744, 0.45470], -[16604, 0.89657, 0.90394, 0.48464], -[16605, 0.88293, 0.84004, 0.13115], -[16606, 0.98130, 0.70297, 0.09469], -[16607, 0.88544, 0.91501, 0.48380], -[16608, 0.97353, 0.75925, 0.18806], -[16609, 0.94591, 0.83153, 0.31169], -[16610, 0.77557, 0.98712, 0.28577], -[16611, 0.80264, 0.98490, 0.41259], -[16612, 0.96963, 0.81877, 0.39315], -[16613, 0.80861, 0.86511, 0.03121], -[16614, 0.90376, 0.89664, 0.46260], -[16615, 0.90681, 0.89409, 0.47911], -[16616, 0.88312, 0.79355, 0.03896], -[16617, 0.94790, 0.72818, 0.06015], -[16618, 0.96530, 0.79738, 0.26628], -[16619, 0.84445, 0.91708, 0.23902], -[16620, 0.92295, 0.86609, 0.35717], -[16621, 1.00000, 0.62990, 0.02500], -[16622, 0.86760, 0.86511, 0.15167], -[16623, 0.81970, 0.91768, 0.17058], -[16624, 0.84186, 0.94763, 0.37400], -[16625, 0.79964, 0.96996, 0.29368], -[16626, 0.97399, 0.71581, 0.09772], -[16627, 0.72252, 0.98262, 0.13183], -[16628, 1.00000, 0.78146, 0.38750], -[16629, 0.90991, 0.78041, 0.06812], -[16630, 0.74019, 1.00000, 0.22500], -[16631, 0.86806, 0.78750, 0.00000], -[16632, 0.78349, 1.00000, 0.40000], -[16633, 0.94249, 0.85614, 0.44785], -[16634, 0.96802, 0.68591, 0.03475], -[16635, 0.91781, 0.80399, 0.13221], -[16636, 0.87335, 0.81151, 0.04941], -[16637, 0.79052, 0.97989, 0.30185], -[16638, 0.87592, 0.86787, 0.17758], -[16639, 0.91136, 0.73750, 0.00000], -[16640, 0.83450, 0.96072, 0.42777], -[16641, 0.81769, 0.87905, 0.07147], -[16642, 0.84367, 0.95404, 0.44338], -[16643, 0.87808, 0.83307, 0.09968], -[16644, 0.70119, 0.95211, 0.02338], -[16645, 0.76184, 1.00000, 0.28750], -[16646, 0.87133, 0.92543, 0.40036], -[16647, 0.97631, 0.65000, 0.00000], -[16648, 0.83700, 0.84218, 0.03520], -[16649, 0.92525, 0.77666, 0.09176], -[16650, 0.77754, 0.93021, 0.10493], -[16651, 0.67524, 1.00000, 0.08750], -[16652, 0.87459, 0.92776, 0.47591], -[16653, 0.69689, 1.00000, 0.12500], -[16654, 0.82323, 0.86061, 0.04399], -[16655, 0.89823, 0.86325, 0.22707], -[16656, 0.95632, 0.79113, 0.20660], -[16657, 0.90115, 0.76192, 0.01633], -[16658, 0.86798, 0.85813, 0.12980], -[16659, 0.91184, 0.88127, 0.36312], -[16660, 0.74098, 0.96941, 0.12834], -[16661, 0.90099, 0.87376, 0.27160], -[16662, 0.73816, 0.91250, 0.00000], -[16663, 1.00000, 0.73816, 0.21250], -[16664, 0.91250, 0.89175, 0.50000], -[16665, 1.00000, 0.75981, 0.27500], -[16666, 0.75877, 0.96317, 0.14692], -[16667, 0.80221, 0.90686, 0.09731], -[16668, 0.78388, 0.96539, 0.21416], -[16669, 0.90102, 0.86807, 0.24935], -[16670, 0.93783, 0.79746, 0.16417], -[16671, 0.90342, 0.89696, 0.41123], -[16672, 0.89373, 0.90055, 0.36190], -[16673, 0.79810, 0.98250, 0.33691], -[16674, 0.82949, 0.94560, 0.28334], -[16675, 0.80544, 0.94943, 0.21871], -[16676, 0.95588, 0.69582, 0.01887], -[16677, 0.95928, 0.75070, 0.11839], -[16678, 0.82192, 0.97259, 0.41084], -[16679, 0.78349, 1.00000, 0.37500], -[16680, 0.94514, 0.82727, 0.27232], -[16681, 1.00000, 0.78146, 0.36250], -[16682, 0.65359, 1.00000, 0.05000], -[16683, 0.85460, 0.87573, 0.13600], -[16684, 0.80943, 0.98694, 0.47640], -[16685, 0.85651, 0.94448, 0.43495], -[16686, 0.78726, 0.88582, 0.02516], -[16687, 0.97808, 0.70167, 0.07431], -[16688, 0.71854, 1.00000, 0.16250], -[16689, 0.69314, 0.97001, 0.04296], -[16690, 0.82012, 0.85430, 0.02215], -[16691, 0.92133, 0.79356, 0.10976], -[16692, 0.81234, 0.97044, 0.32885], -[16693, 0.70395, 0.98049, 0.08280], -[16694, 0.98303, 0.65648, 0.01659], -[16695, 0.94225, 0.76228, 0.09739], -[16696, 0.71991, 0.95101, 0.04355], -[16697, 0.77895, 0.91452, 0.06640], -[16698, 0.93178, 0.81435, 0.18415], -[16699, 0.93714, 0.82650, 0.23570], -[16700, 0.74619, 0.97829, 0.15722], -[16701, 0.82476, 0.83750, 0.00000], -[16702, 0.67628, 0.97882, 0.03483], -[16703, 0.98576, 0.80021, 0.35941], -[16704, 0.86043, 0.91287, 0.25875], -[16705, 0.86270, 0.91746, 0.28530], -[16706, 0.80645, 0.93920, 0.18422], -[16707, 0.97410, 0.79943, 0.28968], -[16708, 0.75039, 0.94934, 0.08993], -[16709, 0.88088, 0.92180, 0.41709], -[16710, 0.98250, 0.72429, 0.12183], -[16711, 1.00000, 0.69486, 0.11250], -[16712, 0.89506, 0.86281, 0.20433], -[16713, 0.80581, 0.91562, 0.11823], -[16714, 0.77159, 0.89406, 0.01130], -[16715, 0.93825, 0.73752, 0.04249], -[16716, 1.00000, 0.67321, 0.07500], -[16717, 0.80863, 0.88155, 0.04964], -[16718, 0.97522, 0.81113, 0.34217], -[16719, 0.78682, 0.89937, 0.04616], -[16720, 0.95168, 0.84405, 0.37383], -[16721, 0.95466, 0.68750, 0.00000], -[16722, 0.97500, 0.82679, 0.50000], -[16723, 0.90502, 0.90053, 0.43433], -[16724, 0.94313, 0.80898, 0.19932], -[16725, 0.97583, 0.77224, 0.20686], -[16726, 0.89654, 0.89379, 0.32116], -[16727, 0.86507, 0.92740, 0.33773], -[16728, 0.89242, 0.80214, 0.05812], -[16729, 0.82791, 0.90942, 0.14886], -[16730, 1.00000, 0.71651, 0.15000], -[16731, 0.86920, 0.93073, 0.38037], -[16732, 0.76985, 0.98175, 0.21788], -[16733, 0.78349, 1.00000, 0.35000], -[16734, 0.93883, 0.74941, 0.05993], -[16735, 0.86509, 0.93874, 0.41538], -[16736, 0.76184, 1.00000, 0.26250], -[16737, 1.00000, 0.78146, 0.33750], -[16738, 0.97344, 0.81913, 0.36362], -[16739, 0.83687, 0.93330, 0.24349], -[16740, 0.88323, 0.82730, 0.08437], -[16741, 0.85918, 0.94738, 0.46011], -[16742, 0.75981, 0.90000, 0.00000], -[16743, 0.87659, 0.90406, 0.27285], -[16744, 0.80895, 0.98330, 0.37268], -[16745, 0.95050, 0.74651, 0.07949], -[16746, 0.85000, 0.95670, 0.50000], -[16747, 0.75246, 0.98406, 0.17875], -[16748, 0.96403, 0.80260, 0.24634], -[16749, 0.74019, 1.00000, 0.20000], -[16750, 0.80442, 0.89772, 0.06992], -[16751, 0.92097, 0.88478, 0.41588], -[16752, 0.84741, 0.95475, 0.40755], -[16753, 0.92763, 0.84423, 0.24501], -[16754, 1.00000, 0.65155, 0.03750], -[16755, 0.91158, 0.83099, 0.15747], -[16756, 0.84918, 0.85698, 0.07176], -[16757, 0.94210, 0.83176, 0.25527], -[16758, 0.92573, 0.76820, 0.06155], -[16759, 0.96174, 0.70777, 0.03785], -[16760, 0.89765, 0.81026, 0.07896], -[16761, 0.74280, 0.94032, 0.04859], -[16762, 1.00000, 0.75981, 0.25000], -[16763, 0.82859, 0.97504, 0.44940], -[16764, 0.79780, 0.90941, 0.08002], -[16765, 1.00000, 0.80000, 0.50000], -[16766, 0.80000, 1.00000, 0.50000], -[16767, 0.84867, 0.91068, 0.19918], -[16768, 0.83616, 0.94079, 0.26363], -[16769, 0.96030, 0.84630, 0.45844], -[16770, 0.98299, 0.81662, 0.41563], -[16771, 0.89941, 0.90437, 0.38367], -[16772, 0.81509, 0.95101, 0.23225], -[16773, 0.96759, 0.83907, 0.48276], -[16774, 1.00000, 0.62500, 0.00000], -[16775, 0.62500, 1.00000, 0.00000], -[16776, 0.81729, 0.95568, 0.25637], -[16777, 0.98125, 0.74537, 0.15000], -[16778, 0.79802, 0.96504, 0.23011], -[16779, 0.88715, 0.91685, 0.38377], -[16780, 0.92169, 0.88205, 0.38305], -[16781, 0.96105, 0.83027, 0.33116], -[16782, 0.94752, 0.86185, 0.46950], -[16783, 0.93823, 0.85842, 0.34378], -[16784, 0.92878, 0.74334, 0.02417], -[16785, 0.83550, 0.95638, 0.32986], -[16786, 0.77685, 0.95235, 0.13777], -[16787, 0.94773, 0.78653, 0.14656], -[16788, 0.75422, 0.92801, 0.03987], -[16789, 0.91666, 0.88188, 0.34527], -[16790, 0.89632, 0.85806, 0.17982], -[16791, 0.88971, 0.77500, 0.00000], -[16792, 0.76866, 0.91761, 0.04239], -[16793, 0.93661, 0.87044, 0.41395], -[16794, 0.92636, 0.87055, 0.33764], -[16795, 0.97109, 0.68029, 0.01363], -[16796, 0.96902, 0.83463, 0.41755], -[16797, 1.00000, 0.73816, 0.18750], -[16798, 0.72884, 0.96991, 0.08684], -[16799, 0.98538, 0.78140, 0.25284], -[16800, 0.72458, 0.94382, 0.02373], -[16801, 0.88626, 0.91484, 0.35705], -[16802, 0.89544, 0.91220, 0.40490], -[16803, 0.91575, 0.77386, 0.04659], -[16804, 0.97099, 0.72393, 0.07993], -[16805, 0.86896, 0.88767, 0.18311], -[16806, 0.78734, 0.96218, 0.18701], -[16807, 0.83213, 0.95585, 0.30599], -[16808, 0.76213, 0.91343, 0.02169], -[16809, 0.86482, 0.84540, 0.07389], -[16810, 0.95089, 0.77361, 0.12367], -[16811, 0.90000, 0.91340, 0.50000], -[16812, 0.81558, 0.97121, 0.31016], -[16813, 0.78349, 1.00000, 0.32500], -[16814, 0.86230, 0.94357, 0.39624], -[16815, 0.96076, 0.82769, 0.30872], -[16816, 0.89443, 0.83409, 0.11353], -[16817, 0.80601, 0.98741, 0.35667], -[16818, 0.83006, 0.97173, 0.38944], -[16819, 0.76646, 0.97342, 0.16760], -[16820, 0.83954, 0.95888, 0.35416], -[16821, 1.00000, 0.80311, 0.47500], -[16822, 0.90207, 0.88873, 0.29495], -[16823, 0.69689, 1.00000, 0.10000], -[16824, 1.00000, 0.78146, 0.31250], -[16825, 0.80949, 0.93571, 0.16086], -[16826, 0.91396, 0.85350, 0.21348], -[16827, 0.96838, 0.77973, 0.18353], -[16828, 0.66250, 0.97835, 0.00000], -[16829, 0.93301, 0.72500, 0.00000], -[16830, 0.88618, 0.91047, 0.32140], -[16831, 0.86094, 0.86609, 0.10639], -[16832, 0.96250, 0.84845, 0.50000], -[16833, 0.96855, 0.71624, 0.05795], -[16834, 0.95084, 0.84471, 0.32984], -[16835, 0.84175, 0.96860, 0.48651], -[16836, 0.84319, 0.87846, 0.09466], -[16837, 0.84641, 0.82500, 0.00000], -[16838, 0.88578, 0.79651, 0.02245], -[16839, 0.88682, 0.85622, 0.14279], -[16840, 0.98965, 0.79079, 0.29392], -[16841, 0.67524, 1.00000, 0.06250], -[16842, 0.90044, 0.82186, 0.09858], -[16843, 0.96239, 0.82201, 0.28653], -[16844, 1.00000, 0.80311, 0.45000], -[16845, 0.95402, 0.72715, 0.04321], -[16846, 0.86617, 0.90999, 0.23670], -[16847, 0.71854, 1.00000, 0.13750], -[16848, 0.88908, 0.88141, 0.21640], -[16849, 0.74676, 0.92921, 0.02369], -[16850, 0.80429, 1.00000, 0.46458], -[16851, 0.78146, 0.88750, 0.00000], -[16852, 0.89911, 0.91578, 0.46423], -[16853, 0.92564, 0.88952, 0.48038], -[16854, 0.95684, 0.78945, 0.16885], -[16855, 0.83330, 0.92603, 0.18927], -[16856, 0.83943, 0.84203, 0.01524], -[16857, 0.83220, 0.87117, 0.05551], -[16858, 0.76184, 1.00000, 0.23750], -[16859, 0.93736, 0.79359, 0.12462], -[16860, 0.76801, 0.94571, 0.09356], -[16861, 0.89726, 0.91774, 0.44878], -[16862, 0.70411, 0.98125, 0.06250], -[16863, 0.76354, 0.94233, 0.07681], -[16864, 0.91407, 0.79537, 0.07345], -[16865, 0.81312, 0.92599, 0.13737], -[16866, 0.89373, 0.88944, 0.25353], -[16867, 1.00000, 0.80311, 0.42500], -[16868, 0.85857, 0.94473, 0.35452], -[16869, 0.78407, 0.98325, 0.23652], -[16870, 0.93707, 0.86856, 0.36362], -[16871, 0.93435, 0.85031, 0.26499], -[16872, 0.82420, 0.97515, 0.35468], -[16873, 0.91146, 0.82247, 0.12016], -[16874, 0.80514, 1.00000, 0.43750], -[16875, 0.73611, 0.95376, 0.05190], -[16876, 0.96625, 0.84093, 0.39192], -[16877, 0.65359, 1.00000, 0.02500], -[16878, 1.00000, 0.75981, 0.22500], -[16879, 1.00000, 0.69486, 0.08750], -[16880, 0.93816, 0.87805, 0.45176], -[16881, 0.74019, 1.00000, 0.17500], -[16882, 0.95267, 0.85860, 0.40564], -[16883, 0.91862, 0.87998, 0.31166], -[16884, 0.78349, 1.00000, 0.30000], -[16885, 0.91948, 0.76423, 0.02626], -[16886, 0.95541, 0.84801, 0.35152], -[16887, 1.00000, 0.71651, 0.12500], -[16888, 0.87962, 0.93615, 0.43691], -[16889, 0.85366, 0.88348, 0.11925], -[16890, 0.82177, 0.96659, 0.28854], -[16891, 0.91406, 0.89945, 0.40064], -[16892, 0.85936, 0.95683, 0.47979], -[16893, 0.93577, 0.85719, 0.29013], -[16894, 0.74441, 0.95869, 0.07423], -[16895, 0.84006, 0.87709, 0.07626], -[16896, 0.98830, 0.79096, 0.27123], -[16897, 0.79437, 0.95024, 0.15247], -[16898, 0.82761, 0.89368, 0.08612], -[16899, 1.00000, 0.80311, 0.40000], -[16900, 0.82705, 0.91168, 0.12602], -[16901, 0.96185, 0.85205, 0.43627], -[16902, 0.98177, 0.82567, 0.40154], -[16903, 0.85434, 0.95941, 0.42870], -[16904, 0.97717, 0.81322, 0.30176], -[16905, 0.91079, 0.90743, 0.44911], -[16906, 1.00000, 0.67321, 0.05000], -[16907, 1.00000, 0.78146, 0.28750], -[16908, 0.80514, 1.00000, 0.41250], -[16909, 0.83627, 0.96990, 0.37399], -[16910, 0.97702, 0.83545, 0.44091], -[16911, 0.93217, 0.87453, 0.35036], -[16912, 0.98656, 0.82625, 0.48077], -[16913, 0.80768, 0.97597, 0.27302], -[16914, 0.87439, 0.92417, 0.30566], -[16915, 0.93941, 0.82879, 0.20482], -[16916, 0.98089, 0.69986, 0.04765], -[16917, 0.96630, 0.74882, 0.09732], -[16918, 0.77534, 0.95167, 0.11283], -[16919, 0.88728, 0.93157, 0.45789], -[16920, 0.90926, 0.77775, 0.02540], -[16921, 0.76777, 0.93209, 0.05429], -[16922, 0.68845, 0.97409, 0.01594], -[16923, 0.94009, 0.87303, 0.39279], -[16924, 0.88369, 0.85237, 0.11251], -[16925, 0.80932, 0.95512, 0.19934], -[16926, 0.86510, 0.88793, 0.15238], -[16927, 0.83141, 0.98268, 0.47155], -[16928, 0.93773, 0.80693, 0.14325], -[16929, 0.92440, 0.86634, 0.27046], -[16930, 0.89963, 0.79570, 0.03601], -[16931, 0.97030, 0.83535, 0.36359], -[16932, 0.97645, 0.79267, 0.22413], -[16933, 0.89552, 0.92228, 0.42532], -[16934, 0.93274, 0.88501, 0.42997], -[16935, 0.90298, 0.85225, 0.15862], -[16936, 0.84866, 0.85734, 0.04922], -[16937, 0.83750, 0.97835, 0.50000], -[16938, 0.92888, 0.78326, 0.07293], -[16939, 1.00000, 0.73816, 0.16250], -[16940, 0.97631, 0.67500, 0.00000], -[16941, 0.95239, 0.81766, 0.21115], -[16942, 0.81170, 0.98701, 0.33750], -[16943, 0.80353, 0.97530, 0.24973], -[16944, 0.95000, 0.87010, 0.50000], -[16945, 0.90033, 0.90655, 0.33500], -[16946, 0.91585, 0.84638, 0.17671], -[16947, 0.92954, 0.87033, 0.30468], -[16948, 0.77759, 0.98088, 0.19502], -[16949, 0.94543, 0.85441, 0.30974], -[16950, 0.85493, 0.93459, 0.26378], -[16951, 0.95983, 0.80489, 0.19803], -[16952, 0.80311, 0.87500, 0.00000], -[16953, 1.00000, 0.80311, 0.37500], -[16954, 0.95372, 0.84159, 0.29258], -[16955, 0.80514, 1.00000, 0.38750], -[16956, 0.82429, 0.94198, 0.19256], -[16957, 0.90731, 0.84048, 0.13700], -[16958, 0.89683, 0.89987, 0.28233], -[16959, 0.93619, 0.75760, 0.04049], -[16960, 0.92643, 0.84364, 0.19690], -[16961, 0.88750, 0.93505, 0.50000], -[16962, 0.91136, 0.76250, 0.00000], -[16963, 0.97883, 0.76962, 0.16581], -[16964, 0.87111, 0.83336, 0.04269], -[16965, 0.97427, 0.76043, 0.13181], -[16966, 0.76184, 1.00000, 0.21250], -[16967, 0.79965, 0.93768, 0.11986], -[16968, 0.87396, 0.81895, 0.02165], -[16969, 0.89010, 0.82454, 0.06263], -[16970, 0.86806, 0.81250, 0.00000], -[16971, 0.88608, 0.89887, 0.23404], -[16972, 0.84718, 0.89962, 0.13005], -[16973, 0.87828, 0.89684, 0.20219], -[16974, 0.78349, 1.00000, 0.27500], -[16975, 0.96413, 0.81211, 0.22514], -[16976, 0.92408, 0.82495, 0.13918], -[16977, 0.93985, 0.86709, 0.32805], -[16978, 0.93433, 0.84414, 0.21846], -[16979, 0.75910, 0.96526, 0.10394], -[16980, 0.93147, 0.88243, 0.36392], -[16981, 0.98403, 0.72921, 0.09404], -[16982, 0.82418, 0.87393, 0.02816], -[16983, 0.85288, 0.92524, 0.21314], -[16984, 0.88766, 0.81367, 0.03547], -[16985, 0.85981, 0.94173, 0.30070], -[16986, 0.71651, 0.95000, 0.00000], -[16987, 0.78429, 0.90859, 0.02528], -[16988, 0.82286, 0.95204, 0.21248], -[16989, 0.98055, 0.74604, 0.11509], -[16990, 0.69689, 1.00000, 0.07500], -[16991, 0.95003, 0.87133, 0.43264], -[16992, 0.87471, 0.85517, 0.08777], -[16993, 0.71854, 1.00000, 0.11250], -[16994, 0.81897, 0.96462, 0.24408], -[16995, 1.00000, 0.78146, 0.26250], -[16996, 0.80514, 1.00000, 0.36250], -[16997, 1.00000, 0.75981, 0.20000], -[16998, 0.87644, 0.93694, 0.35368], -[16999, 0.94336, 0.88147, 0.47698], -[17000, 1.00000, 0.80311, 0.35000], -[17001, 0.86646, 0.93994, 0.31615], -[17002, 0.92755, 0.83637, 0.17104], -[17003, 0.94459, 0.78570, 0.10161], -[17004, 0.90678, 0.91972, 0.48544], -[17005, 0.67471, 0.98731, 0.01176], -[17006, 0.94636, 0.76768, 0.07162], -[17007, 0.84057, 0.92365, 0.17022], -[17008, 0.85742, 0.84492, 0.03136], -[17009, 0.69122, 0.97012, 0.00000], -[17010, 0.95466, 0.71250, 0.00000], -[17011, 0.82906, 0.92777, 0.15218], -[17012, 0.96814, 0.82168, 0.26139], -[17013, 0.95742, 0.80645, 0.17971], -[17014, 0.82328, 0.91362, 0.10345], -[17015, 0.67524, 1.00000, 0.03750], -[17016, 0.74019, 1.00000, 0.15000], -[17017, 0.90399, 0.88450, 0.23359], -[17018, 0.98125, 0.83198, 0.37500], -[17019, 0.92672, 0.89973, 0.45097], -[17020, 0.85824, 0.95041, 0.32417], -[17021, 0.93166, 0.79690, 0.09031], -[17022, 0.85281, 0.91884, 0.18464], -[17023, 0.88997, 0.84309, 0.08985], -[17024, 0.88256, 0.91179, 0.25269], -[17025, 0.98158, 0.84087, 0.46387], -[17026, 0.84046, 0.86241, 0.02892], -[17027, 0.94086, 0.82010, 0.16180], -[17028, 0.78004, 0.97069, 0.15122], -[17029, 1.00000, 0.65000, 0.00000], -[17030, 0.65000, 1.00000, 0.00000], -[17031, 0.79191, 0.93220, 0.07992], -[17032, 0.71839, 0.96479, 0.02470], -[17033, 0.83205, 0.96281, 0.26836], -[17034, 1.00000, 0.71651, 0.10000], -[17035, 0.87586, 0.90861, 0.21593], -[17036, 0.87800, 0.94964, 0.46801], -[17037, 0.98894, 0.83045, 0.42193], -[17038, 0.72523, 0.96788, 0.04062], -[17039, 0.73816, 0.93750, 0.00000], -[17040, 0.73098, 0.97455, 0.06446], -[17041, 0.93750, 0.89175, 0.50000], -[17042, 0.82476, 0.86250, 0.00000], -[17043, 1.00000, 0.69486, 0.06250], -[17044, 0.82913, 0.93762, 0.17176], -[17045, 0.88864, 0.87591, 0.15731], -[17046, 0.80683, 0.92922, 0.09975], -[17047, 0.80514, 1.00000, 0.33750], -[17048, 0.85099, 0.97419, 0.46146], -[17049, 0.89956, 0.90928, 0.30310], -[17050, 0.76256, 0.98556, 0.15035], -[17051, 0.83998, 0.94529, 0.22444], -[17052, 0.95429, 0.75031, 0.05118], -[17053, 0.87209, 0.94863, 0.37742], -[17054, 0.75946, 0.95082, 0.05877], -[17055, 1.00000, 0.80311, 0.32500], -[17056, 0.93116, 0.89437, 0.40672], -[17057, 0.81543, 0.88770, 0.02791], -[17058, 0.96005, 0.82905, 0.24120], -[17059, 0.91478, 0.86295, 0.19257], -[17060, 0.91703, 0.89789, 0.32981], -[17061, 0.93386, 0.80550, 0.10590], -[17062, 1.00000, 0.73816, 0.13750], -[17063, 0.81026, 0.88553, 0.01454], -[17064, 0.78349, 1.00000, 0.25000], -[17065, 0.73636, 0.95743, 0.03359], -[17066, 0.93521, 0.89524, 0.47394], -[17067, 0.89582, 0.93512, 0.48056], -[17068, 0.94400, 0.84635, 0.23527], -[17069, 0.98125, 0.83198, 0.35000], -[17070, 0.86784, 0.95766, 0.41324], -[17071, 0.98515, 0.80605, 0.26002], -[17072, 0.76184, 1.00000, 0.18750], -[17073, 0.88788, 0.93692, 0.39052], -[17074, 0.84364, 0.93746, 0.20317], -[17075, 0.97918, 0.79443, 0.20203], -[17076, 0.95613, 0.86698, 0.38629], -[17077, 1.00000, 0.67321, 0.02500], -[17078, 0.96550, 0.84351, 0.31221], -[17079, 0.76208, 0.93856, 0.03379], -[17080, 0.87610, 0.88343, 0.13727], -[17081, 1.00000, 0.78146, 0.23750], -[17082, 0.92180, 0.91061, 0.47345], -[17083, 0.85918, 0.91097, 0.16575], -[17084, 0.98002, 0.70283, 0.02490], -[17085, 0.91877, 0.81547, 0.08631], -[17086, 0.95109, 0.74444, 0.02936], -[17087, 0.91127, 0.87630, 0.21341], -[17088, 0.84123, 0.98125, 0.40000], -[17089, 0.96131, 0.86842, 0.45236], -[17090, 0.98203, 0.84624, 0.49070], -[17091, 0.85736, 0.96335, 0.36776], -[17092, 1.00000, 0.82500, 0.50000], -[17093, 0.82500, 1.00000, 0.50000], -[17094, 0.81174, 0.96967, 0.21444], -[17095, 0.90488, 0.91916, 0.36936], -[17096, 0.87500, 0.95670, 0.50000], -[17097, 0.92796, 0.86379, 0.22849], -[17098, 0.90167, 0.83132, 0.07937], -[17099, 0.93177, 0.86484, 0.24498], -[17100, 0.98024, 0.82912, 0.31854], -[17101, 0.90620, 0.84761, 0.12370], -[17102, 0.84882, 0.97842, 0.43907], -[17103, 0.93520, 0.81481, 0.12183], -[17104, 0.88971, 0.80000, 0.00000], -[17105, 0.81415, 0.95479, 0.17264], -[17106, 1.00000, 0.82476, 0.46250], -[17107, 0.86542, 0.96460, 0.44640], -[17108, 0.86093, 0.96392, 0.39042], -[17109, 0.88364, 0.84099, 0.05916], -[17110, 0.75981, 0.92500, 0.00000], -[17111, 1.00000, 0.75981, 0.17500], -[17112, 0.93301, 0.75000, 0.00000], -[17113, 0.87866, 0.87482, 0.11822], -[17114, 0.86274, 0.87473, 0.08316], -[17115, 0.80514, 1.00000, 0.31250], -[17116, 0.88681, 0.93208, 0.33201], -[17117, 0.75460, 0.98355, 0.11707], -[17118, 0.88648, 0.92391, 0.29023], -[17119, 0.96406, 0.76371, 0.08668], -[17120, 0.83858, 0.95667, 0.24434], -[17121, 0.74571, 0.98211, 0.09594], -[17122, 0.75846, 0.93395, 0.01378], -[17123, 0.83250, 0.89478, 0.06371], -[17124, 1.00000, 0.82476, 0.43750], -[17125, 0.82679, 1.00000, 0.47500], -[17126, 0.95733, 0.80555, 0.15513], -[17127, 0.79530, 0.98561, 0.21621], -[17128, 0.84436, 0.96254, 0.28775], -[17129, 0.98733, 0.72513, 0.07110], -[17130, 0.98125, 0.77424, 0.15000], -[17131, 0.96587, 0.72289, 0.02112], -[17132, 0.83401, 0.98125, 0.33750], -[17133, 1.00000, 0.80311, 0.30000], -[17134, 0.79195, 0.94661, 0.09781], -[17135, 0.85093, 0.97651, 0.41395], -[17136, 0.84712, 0.90383, 0.11169], -[17137, 0.93293, 0.78486, 0.05376], -[17138, 0.85653, 0.94905, 0.27370], -[17139, 0.81678, 0.98814, 0.29470], -[17140, 0.87636, 0.92917, 0.26623], -[17141, 0.86998, 0.93015, 0.24702], -[17142, 0.82679, 1.00000, 0.45000], -[17143, 0.97216, 0.86068, 0.48316], -[17144, 0.97267, 0.76684, 0.10995], -[17145, 0.71854, 1.00000, 0.08750], -[17146, 0.91537, 0.91737, 0.41483], -[17147, 0.97285, 0.73882, 0.05831], -[17148, 0.90754, 0.91191, 0.32023], -[17149, 0.77721, 0.98598, 0.16628], -[17150, 0.87589, 0.95663, 0.42721], -[17151, 0.87103, 0.94139, 0.29330], -[17152, 1.00000, 0.82476, 0.41250], -[17153, 0.69689, 1.00000, 0.05000], -[17154, 0.86512, 0.92946, 0.22459], -[17155, 0.80423, 0.92138, 0.06122], -[17156, 0.97876, 0.81639, 0.24739], -[17157, 0.87222, 0.94918, 0.33661], -[17158, 0.74019, 1.00000, 0.12500], -[17159, 0.98451, 0.81944, 0.28090], -[17160, 0.91909, 0.89329, 0.28510], -[17161, 0.84641, 0.85000, 0.00000], -[17162, 0.91693, 0.90041, 0.30659], -[17163, 0.81418, 0.92178, 0.07990], -[17164, 0.92409, 0.90651, 0.38409], -[17165, 0.94343, 0.78672, 0.07554], -[17166, 0.88549, 0.94986, 0.44675], -[17167, 0.82679, 1.00000, 0.42500], -[17168, 0.85380, 0.89134, 0.09273], -[17169, 0.78349, 1.00000, 0.22500], -[17170, 0.89510, 0.82604, 0.04602], -[17171, 0.84603, 0.97183, 0.32833], -[17172, 0.97055, 0.78904, 0.14619], -[17173, 0.92500, 0.91340, 0.50000], -[17174, 0.89270, 0.93579, 0.36813], -[17175, 0.94694, 0.77155, 0.05496], -[17176, 0.98445, 0.84411, 0.40769], -[17177, 0.94944, 0.83044, 0.18456], -[17178, 0.97458, 0.85343, 0.38812], -[17179, 0.90708, 0.89985, 0.25789], -[17180, 0.91835, 0.90771, 0.34538], -[17181, 0.81196, 0.98010, 0.23258], -[17182, 0.71279, 0.98556, 0.03926], -[17183, 0.80170, 0.97794, 0.19554], -[17184, 0.95838, 0.83359, 0.21996], -[17185, 0.87302, 0.85718, 0.05855], -[17186, 0.89549, 0.91389, 0.26601], -[17187, 0.85799, 0.94205, 0.23831], -[17188, 0.96706, 0.85984, 0.36739], -[17189, 0.97341, 0.84678, 0.33351], -[17190, 1.00000, 0.82476, 0.38750], -[17191, 0.97631, 0.70000, 0.00000], -[17192, 0.87498, 0.86553, 0.07755], -[17193, 0.78146, 0.91250, 0.00000], -[17194, 1.00000, 0.78146, 0.21250], -[17195, 0.90220, 0.93326, 0.40814], -[17196, 0.80514, 1.00000, 0.28750], -[17197, 0.82679, 1.00000, 0.40000], -[17198, 0.98036, 0.72106, 0.03884], -[17199, 0.91584, 0.81589, 0.06471], -[17200, 1.00000, 0.71651, 0.07500], -[17201, 0.77704, 0.93037, 0.02595], -[17202, 0.76184, 1.00000, 0.16250], -[17203, 0.90684, 0.79771, 0.01430], -[17204, 0.95736, 0.80188, 0.13246], -[17205, 0.84553, 0.93891, 0.18664], -[17206, 0.85950, 0.96557, 0.34584], -[17207, 0.83601, 0.97818, 0.30233], -[17208, 0.88639, 0.94922, 0.40979], -[17209, 1.00000, 0.73816, 0.11250], -[17210, 0.90855, 0.84235, 0.09956], -[17211, 1.00000, 0.80311, 0.27500], -[17212, 0.91778, 0.80781, 0.05172], -[17213, 0.85012, 0.85978, 0.01616], -[17214, 0.98239, 0.85208, 0.42600], -[17215, 0.97833, 0.83546, 0.29614], -[17216, 0.95983, 0.84631, 0.25634], -[17217, 0.82295, 0.93294, 0.11358], -[17218, 0.74879, 0.95292, 0.02226], -[17219, 0.77558, 0.97421, 0.11720], -[17220, 0.86311, 0.90834, 0.14329], -[17221, 0.83547, 0.93090, 0.13535], -[17222, 0.79535, 0.96511, 0.13438], -[17223, 0.94097, 0.76197, 0.01854], -[17224, 0.90664, 0.88144, 0.18536], -[17225, 0.91619, 0.92060, 0.39503], -[17226, 0.74746, 0.98092, 0.07913], -[17227, 0.84734, 0.91856, 0.13050], -[17228, 0.91803, 0.88931, 0.24512], -[17229, 0.98074, 0.85684, 0.44841], -[17230, 0.84725, 0.99030, 0.48452], -[17231, 0.84686, 0.98046, 0.35656], -[17232, 0.91447, 0.86837, 0.17026], -[17233, 1.00000, 0.82476, 0.36250], -[17234, 0.87171, 0.96891, 0.47771], -[17235, 0.82679, 1.00000, 0.37500], -[17236, 0.86589, 0.88861, 0.10020], -[17237, 0.93504, 0.89075, 0.32156], -[17238, 1.00000, 0.75981, 0.15000], -[17239, 0.89799, 0.86872, 0.12751], -[17240, 1.00000, 0.69571, 0.03542], -[17241, 0.97298, 0.83804, 0.27396], -[17242, 0.85391, 0.87450, 0.04576], -[17243, 0.88138, 0.84169, 0.03631], -[17244, 0.88329, 0.86809, 0.09160], -[17245, 0.91136, 0.78750, 0.00000], -[17246, 0.86250, 0.97835, 0.50000], -[17247, 0.85480, 0.96621, 0.30786], -[17248, 0.95972, 0.87034, 0.34833], -[17249, 0.78199, 0.94812, 0.06228], -[17250, 0.98482, 0.74398, 0.07722], -[17251, 0.87892, 0.90172, 0.15858], -[17252, 0.96193, 0.86355, 0.32283], -[17253, 0.89685, 0.92928, 0.31371], -[17254, 0.92588, 0.85328, 0.15724], -[17255, 0.95484, 0.86060, 0.27533], -[17256, 0.98125, 0.77424, 0.12500], -[17257, 0.93329, 0.86351, 0.20616], -[17258, 0.94189, 0.89043, 0.34786], -[17259, 0.92212, 0.79583, 0.03134], -[17260, 0.86833, 0.87047, 0.06232], -[17261, 0.90520, 0.93870, 0.44317], -[17262, 0.78349, 1.00000, 0.20000], -[17263, 0.75696, 0.95800, 0.03795], -[17264, 0.94052, 0.87880, 0.28189], -[17265, 0.98174, 0.75833, 0.09297], -[17266, 0.80514, 1.00000, 0.26250], -[17267, 0.82557, 0.95023, 0.15328], -[17268, 0.96233, 0.83088, 0.20274], -[17269, 0.94356, 0.80409, 0.09005], -[17270, 0.86806, 0.83750, 0.00000], -[17271, 0.87217, 0.92135, 0.19116], -[17272, 0.80311, 0.90000, 0.00000], -[17273, 0.94692, 0.87914, 0.31132], -[17274, 0.98286, 0.79832, 0.18084], -[17275, 0.88537, 0.92175, 0.23219], -[17276, 0.95466, 0.73750, 0.00000], -[17277, 0.97919, 0.79424, 0.15975], -[17278, 1.00000, 0.67500, 0.00000], -[17279, 0.67500, 1.00000, 0.00000], -[17280, 0.83167, 0.96903, 0.22598], -[17281, 0.92843, 0.88773, 0.26375], -[17282, 0.95280, 0.88599, 0.38553], -[17283, 0.83715, 0.91119, 0.08180], -[17284, 0.82679, 1.00000, 0.35000], -[17285, 0.77681, 0.98398, 0.13293], -[17286, 0.97468, 0.86923, 0.47102], -[17287, 1.00000, 0.82476, 0.33750], -[17288, 0.78067, 0.96654, 0.09616], -[17289, 0.91843, 0.92714, 0.43936], -[17290, 0.81791, 0.98820, 0.25240], -[17291, 0.90961, 0.92412, 0.34032], -[17292, 0.91250, 0.93505, 0.50000], -[17293, 0.79391, 0.93428, 0.04836], -[17294, 0.87698, 0.95805, 0.35707], -[17295, 1.00000, 0.80311, 0.25000], -[17296, 0.85854, 0.88152, 0.06014], -[17297, 0.91254, 0.93480, 0.46712], -[17298, 0.97500, 0.87010, 0.50000], -[17299, 0.71854, 1.00000, 0.06250], -[17300, 0.74019, 1.00000, 0.10000], -[17301, 0.79865, 0.98218, 0.17495], -[17302, 1.00000, 0.78146, 0.18750], -[17303, 0.85252, 0.92721, 0.15095], -[17304, 0.93293, 0.91274, 0.42978], -[17305, 0.94870, 0.80923, 0.10817], -[17306, 0.82803, 0.90447, 0.04752], -[17307, 0.75306, 0.97287, 0.05837], -[17308, 0.94010, 0.77676, 0.02929], -[17309, 0.94335, 0.87242, 0.25934], -[17310, 0.97030, 0.87325, 0.42912], -[17311, 0.79529, 0.96302, 0.11352], -[17312, 0.77260, 0.96515, 0.07449], -[17313, 0.81126, 0.91714, 0.04149], -[17314, 0.96964, 0.81945, 0.18717], -[17315, 0.96178, 0.78210, 0.08399], -[17316, 0.73874, 0.97637, 0.04076], -[17317, 0.81168, 0.96290, 0.14778], -[17318, 0.93787, 0.83280, 0.12979], -[17319, 0.93319, 0.90458, 0.35466], -[17320, 0.82224, 0.91734, 0.06109], -[17321, 0.92707, 0.78425, 0.01448], -[17322, 0.83682, 0.89143, 0.03595], -[17323, 0.88293, 0.95902, 0.39479], -[17324, 0.89918, 0.92855, 0.30004], -[17325, 0.97140, 0.87058, 0.40306], -[17326, 0.89429, 0.82150, 0.01351], -[17327, 0.69689, 1.00000, 0.02500], -[17328, 0.96155, 0.88236, 0.40896], -[17329, 0.93544, 0.80891, 0.07317], -[17330, 0.76184, 1.00000, 0.13750], -[17331, 0.77644, 0.94813, 0.04156], -[17332, 0.81897, 0.89826, 0.01568], -[17333, 0.81769, 0.95006, 0.12437], -[17334, 0.83596, 0.98236, 0.27975], -[17335, 0.94798, 0.90035, 0.44232], -[17336, 0.91026, 0.93692, 0.42086], -[17337, 0.86777, 0.90449, 0.12350], -[17338, 0.90317, 0.91161, 0.24257], -[17339, 0.82582, 0.96905, 0.19653], -[17340, 0.83825, 0.88158, 0.01683], -[17341, 0.95886, 0.88126, 0.36851], -[17342, 0.93466, 0.89376, 0.29686], -[17343, 0.90055, 0.94945, 0.46344], -[17344, 0.87495, 0.95525, 0.31082], -[17345, 0.90980, 0.81507, 0.02904], -[17346, 0.98351, 0.81988, 0.22671], -[17347, 0.82679, 1.00000, 0.32500], -[17348, 0.96646, 0.88320, 0.48729], -[17349, 0.96201, 0.88747, 0.46517], -[17350, 0.89871, 0.90950, 0.21807], -[17351, 0.98268, 0.81531, 0.20970], -[17352, 0.93375, 0.86041, 0.17987], -[17353, 0.96178, 0.79856, 0.11017], -[17354, 0.96440, 0.86294, 0.30001], -[17355, 0.90168, 0.85420, 0.08519], -[17356, 0.86887, 0.97720, 0.42809], -[17357, 1.00000, 0.73816, 0.08750], -[17358, 0.94400, 0.90208, 0.39858], -[17359, 1.00000, 0.82476, 0.31250], -[17360, 0.86122, 0.94502, 0.21578], -[17361, 1.00000, 0.71651, 0.05000], -[17362, 0.96114, 0.88826, 0.44205], -[17363, 0.79061, 0.95486, 0.07642], -[17364, 0.92745, 0.83164, 0.09446], -[17365, 0.71414, 0.97795, 0.00000], -[17366, 1.00000, 0.84641, 0.47500], -[17367, 0.89379, 0.85588, 0.06910], -[17368, 0.80514, 1.00000, 0.23750], -[17369, 0.89228, 0.95977, 0.48228], -[17370, 0.82476, 0.88750, 0.00000], -[17371, 1.00000, 0.75981, 0.12500], -[17372, 0.95658, 0.76606, 0.03485], -[17373, 0.92326, 0.91344, 0.32144], -[17374, 0.96692, 0.76897, 0.06121], -[17375, 0.79621, 0.98190, 0.15253], -[17376, 1.00000, 0.84641, 0.45000], -[17377, 0.97906, 0.85828, 0.34552], -[17378, 0.95446, 0.82548, 0.14410], -[17379, 0.81300, 0.95039, 0.10617], -[17380, 0.91976, 0.92488, 0.36566], -[17381, 0.92335, 0.88797, 0.22010], -[17382, 0.78349, 1.00000, 0.17500], -[17383, 0.95172, 0.85024, 0.19861], -[17384, 0.97256, 0.74840, 0.03745], -[17385, 0.96293, 0.82529, 0.16544], -[17386, 1.00000, 0.80311, 0.22500], -[17387, 0.89540, 0.90878, 0.19476], -[17388, 0.86145, 0.93308, 0.17118], -[17389, 0.97791, 0.76547, 0.07735], -[17390, 0.93301, 0.77500, 0.00000], -[17391, 0.87087, 0.86883, 0.04401], -[17392, 0.84845, 1.00000, 0.46250], -[17393, 0.94769, 0.84202, 0.16158], -[17394, 0.90342, 0.92733, 0.28635], -[17395, 1.00000, 0.84641, 0.42500], -[17396, 0.86837, 0.97344, 0.35711], -[17397, 0.95114, 0.85970, 0.22009], -[17398, 0.71692, 0.98765, 0.01762], -[17399, 0.84580, 0.95987, 0.20770], -[17400, 0.88971, 0.82500, 0.00000], -[17401, 0.89886, 0.89663, 0.16759], -[17402, 0.85863, 0.98477, 0.37568], -[17403, 1.00000, 0.85000, 0.50000], -[17404, 0.85000, 1.00000, 0.50000], -[17405, 0.95510, 0.88408, 0.33053], -[17406, 0.89172, 0.89616, 0.14717], -[17407, 0.76823, 0.98567, 0.09871], -[17408, 0.95295, 0.89893, 0.41849], -[17409, 0.86729, 0.96240, 0.28897], -[17410, 0.89816, 0.95482, 0.42855], -[17411, 0.82679, 1.00000, 0.30000], -[17412, 0.98091, 0.83555, 0.24827], -[17413, 0.84845, 1.00000, 0.43750], -[17414, 0.88733, 0.96705, 0.46182], -[17415, 0.89220, 0.95018, 0.34052], -[17416, 0.83819, 0.95795, 0.17730], -[17417, 0.81295, 0.94299, 0.08244], -[17418, 1.00000, 0.78146, 0.16250], -[17419, 0.94444, 0.90389, 0.37428], -[17420, 0.91725, 0.83324, 0.06479], -[17421, 0.90000, 0.95670, 0.50000], -[17422, 1.00000, 0.82476, 0.28750], -[17423, 0.97841, 0.78314, 0.10657], -[17424, 0.88402, 0.84326, 0.01663], -[17425, 0.97598, 0.83140, 0.21274], -[17426, 0.97720, 0.83494, 0.22749], -[17427, 1.00000, 0.84641, 0.40000], -[17428, 0.88601, 0.91398, 0.17438], -[17429, 0.85292, 0.89716, 0.05925], -[17430, 0.87950, 0.94403, 0.25090], -[17431, 0.80638, 0.94152, 0.06374], -[17432, 0.89367, 0.88025, 0.10812], -[17433, 0.87223, 0.88708, 0.07639], -[17434, 0.93448, 0.92274, 0.44921], -[17435, 0.91540, 0.92301, 0.30606], -[17436, 0.84845, 1.00000, 0.41250], -[17437, 0.92703, 0.91944, 0.34882], -[17438, 0.86879, 0.97076, 0.32550], -[17439, 0.96458, 0.89312, 0.50000], -[17440, 0.74019, 1.00000, 0.07500], -[17441, 0.82794, 0.92853, 0.07444], -[17442, 0.97631, 0.72500, 0.00000], -[17443, 0.91030, 0.86442, 0.10860], -[17444, 0.93681, 0.92233, 0.47215], -[17445, 0.99032, 0.86501, 0.48700], -[17446, 0.92670, 0.84910, 0.11347], -[17447, 0.93586, 0.91928, 0.40925], -[17448, 0.88906, 0.95229, 0.32133], -[17449, 0.97626, 0.84856, 0.26254], -[17450, 0.96829, 0.84964, 0.23525], -[17451, 0.95632, 0.79067, 0.06426], -[17452, 0.89070, 0.94242, 0.28049], -[17453, 0.75981, 0.95000, 0.00000], -[17454, 0.85439, 0.96263, 0.22880], -[17455, 0.76184, 1.00000, 0.11250], -[17456, 0.90769, 0.93641, 0.32691], -[17457, 0.97846, 0.79581, 0.12572], -[17458, 0.93175, 0.82825, 0.07974], -[17459, 0.80514, 1.00000, 0.21250], -[17460, 0.77124, 0.95176, 0.02012], -[17461, 0.97641, 0.73981, 0.02000], -[17462, 0.87417, 0.86175, 0.02638], -[17463, 0.85682, 0.97183, 0.27084], -[17464, 0.88721, 0.92770, 0.21009], -[17465, 0.84641, 0.87500, 0.00000], -[17466, 1.00000, 0.84641, 0.37500], -[17467, 0.91186, 0.90083, 0.20136], -[17468, 0.81958, 0.98125, 0.18750], -[17469, 0.84772, 0.93213, 0.11949], -[17470, 0.82979, 0.93764, 0.09433], -[17471, 0.79885, 0.93378, 0.02843], -[17472, 0.84845, 1.00000, 0.38750], -[17473, 0.92054, 0.86470, 0.12915], -[17474, 0.98232, 0.85123, 0.29186], -[17475, 0.94046, 0.80152, 0.04589], -[17476, 0.98961, 0.85868, 0.37156], -[17477, 0.91891, 0.91480, 0.27207], -[17478, 0.86421, 0.96111, 0.24950], -[17479, 0.71962, 1.00000, 0.03542], -[17480, 0.83797, 0.98267, 0.24331], -[17481, 0.92616, 0.88145, 0.18509], -[17482, 0.82679, 1.00000, 0.27500], -[17483, 0.84778, 0.95023, 0.16438], -[17484, 0.97697, 0.87522, 0.38127], -[17485, 0.89750, 0.95630, 0.37815], -[17486, 1.00000, 0.80311, 0.20000], -[17487, 0.73763, 0.97006, 0.00000], -[17488, 0.88783, 0.97122, 0.43933], -[17489, 0.77420, 0.96692, 0.05165], -[17490, 0.98475, 0.75518, 0.05794], -[17491, 0.85517, 0.98532, 0.31759], -[17492, 0.93044, 0.92992, 0.42652], -[17493, 0.90579, 0.88835, 0.14437], -[17494, 0.86055, 0.94953, 0.19343], -[17495, 0.93814, 0.85208, 0.13927], -[17496, 1.00000, 0.73816, 0.06250], -[17497, 0.90390, 0.95327, 0.39726], -[17498, 0.78349, 1.00000, 0.15000], -[17499, 0.90881, 0.92154, 0.25259], -[17500, 0.88119, 0.91026, 0.13756], -[17501, 0.95314, 0.87018, 0.23368], -[17502, 1.00000, 0.82476, 0.26250], -[17503, 0.96311, 0.75733, 0.01464], -[17504, 0.91314, 0.95003, 0.48220], -[17505, 0.95000, 0.91340, 0.50000], -[17506, 0.96806, 0.89084, 0.42019], -[17507, 0.92763, 0.91304, 0.29223], -[17508, 1.00000, 0.75981, 0.10000], -[17509, 0.90111, 0.84821, 0.04611], -[17510, 0.98245, 0.85893, 0.31363], -[17511, 0.97577, 0.81112, 0.14262], -[17512, 0.87476, 0.92404, 0.15527], -[17513, 0.98865, 0.74163, 0.04120], -[17514, 0.88781, 0.97126, 0.41651], -[17515, 0.85313, 0.92085, 0.09632], -[17516, 0.84845, 1.00000, 0.36250], -[17517, 0.82402, 0.97576, 0.17175], -[17518, 1.00000, 0.84641, 0.35000], -[17519, 1.00000, 0.71651, 0.02500], -[17520, 0.91521, 0.94254, 0.38541], -[17521, 0.81251, 0.92085, 0.01927], -[17522, 0.78146, 0.93750, 0.00000], -[17523, 0.88848, 0.86061, 0.04203], -[17524, 0.85960, 0.98732, 0.33848], -[17525, 1.00000, 0.70000, 0.00000], -[17526, 0.70000, 1.00000, 0.00000], -[17527, 0.98016, 0.88152, 0.45242], -[17528, 0.93928, 0.88812, 0.23664], -[17529, 0.85578, 0.98213, 0.29135], -[17530, 0.92451, 0.93652, 0.40554], -[17531, 0.91136, 0.81250, 0.00000], -[17532, 0.89084, 0.89721, 0.12272], -[17533, 0.83255, 0.94851, 0.11466], -[17534, 0.81927, 0.93247, 0.05193], -[17535, 0.89611, 0.94824, 0.30167], -[17536, 0.89355, 0.93813, 0.24870], -[17537, 0.97018, 0.88881, 0.39754], -[17538, 1.00000, 0.78146, 0.13750], -[17539, 0.91703, 0.83201, 0.04276], -[17540, 0.91851, 0.87985, 0.14716], -[17541, 0.95466, 0.76250, 0.00000], -[17542, 0.75040, 0.97497, 0.02102], -[17543, 0.91798, 0.88951, 0.16930], -[17544, 0.92805, 0.93223, 0.38544], -[17545, 0.97043, 0.79572, 0.08909], -[17546, 0.96549, 0.86728, 0.25611], -[17547, 0.88175, 0.97551, 0.37872], -[17548, 0.90264, 0.83829, 0.02394], -[17549, 0.80327, 0.96578, 0.09217], -[17550, 0.87916, 0.98022, 0.39712], -[17551, 0.88750, 0.97835, 0.50000], -[17552, 0.94864, 0.83255, 0.11035], -[17553, 0.88419, 0.87611, 0.05776], -[17554, 0.80152, 0.98099, 0.12538], -[17555, 0.85637, 0.91253, 0.07645], -[17556, 0.98394, 0.78162, 0.09202], -[17557, 0.90549, 0.96082, 0.44925], -[17558, 0.96513, 0.88944, 0.34780], -[17559, 0.80514, 1.00000, 0.18750], -[17560, 0.92925, 0.93810, 0.45060], -[17561, 0.82679, 1.00000, 0.25000], -[17562, 0.84845, 1.00000, 0.33750], -[17563, 0.83297, 0.90754, 0.02136], -[17564, 0.94058, 0.90133, 0.27753], -[17565, 0.94625, 0.90738, 0.33276], -[17566, 1.00000, 0.84641, 0.32500], -[17567, 0.86806, 0.86250, 0.00000], -[17568, 0.94385, 0.88116, 0.21637], -[17569, 0.94364, 0.91874, 0.38451], -[17570, 0.85841, 0.88084, 0.01478], -[17571, 0.87887, 0.98675, 0.45364], -[17572, 0.97912, 0.87723, 0.35849], -[17573, 0.87733, 0.96183, 0.26833], -[17574, 0.90805, 0.93293, 0.26842], -[17575, 0.93472, 0.90242, 0.25389], -[17576, 0.85402, 0.97753, 0.24672], -[17577, 1.00000, 0.82476, 0.23750], -[17578, 0.92389, 0.90893, 0.23576], -[17579, 0.74019, 1.00000, 0.05000], -[17580, 0.87831, 0.93786, 0.18469], -[17581, 0.92621, 0.81005, 0.01378], -[17582, 0.87577, 0.95449, 0.23080], -[17583, 0.76184, 1.00000, 0.08750], -[17584, 0.80311, 0.92500, 0.00000], -[17585, 1.00000, 0.80311, 0.17500], -[17586, 0.93191, 0.81625, 0.03514], -[17587, 0.91076, 0.88195, 0.12096], -[17588, 0.81476, 0.98539, 0.15823], -[17589, 0.95940, 0.91106, 0.46387], -[17590, 0.95951, 0.88282, 0.27191], -[17591, 0.97266, 0.87746, 0.31009], -[17592, 0.94686, 0.81443, 0.06147], -[17593, 0.84473, 0.91890, 0.05926], -[17594, 0.94773, 0.92179, 0.43250], -[17595, 0.97050, 0.81683, 0.12101], -[17596, 0.79361, 0.95692, 0.04454], -[17597, 0.95429, 0.78063, 0.01727], -[17598, 0.93750, 0.93505, 0.50000], -[17599, 0.98462, 0.88109, 0.41362], -[17600, 0.95824, 0.78867, 0.03841], -[17601, 0.91584, 0.93406, 0.29440], -[17602, 0.86564, 0.93113, 0.12954], -[17603, 0.91581, 0.94706, 0.36590], -[17604, 0.92397, 0.85655, 0.09192], -[17605, 0.87341, 0.97687, 0.30754], -[17606, 0.78349, 1.00000, 0.12500], -[17607, 0.83609, 0.96791, 0.15562], -[17608, 0.95471, 0.89904, 0.31311], -[17609, 0.84490, 0.97918, 0.21343], -[17610, 0.84033, 0.97822, 0.19680], -[17611, 0.84845, 1.00000, 0.31250], -[17612, 0.94663, 0.79439, 0.02247], -[17613, 0.93459, 0.92405, 0.33141], -[17614, 0.79312, 0.96807, 0.06461], -[17615, 0.93480, 0.87720, 0.16424], -[17616, 0.83632, 0.95903, 0.12969], -[17617, 1.00000, 0.84641, 0.30000], -[17618, 0.91884, 0.90198, 0.18588], -[17619, 0.87612, 0.91083, 0.10086], -[17620, 0.84607, 0.92963, 0.07959], -[17621, 1.00000, 0.86922, 0.46458], -[17622, 0.84820, 0.95339, 0.14165], -[17623, 0.97654, 0.86804, 0.27622], -[17624, 0.90650, 0.91248, 0.17929], -[17625, 0.94349, 0.92126, 0.36439], -[17626, 0.88744, 0.94548, 0.22462], -[17627, 0.95445, 0.86957, 0.19962], -[17628, 1.00000, 0.86806, 0.43750], -[17629, 0.97025, 0.90325, 0.48155], -[17630, 0.87010, 1.00000, 0.47500], -[17631, 0.96750, 0.90389, 0.43076], -[17632, 1.00000, 0.75981, 0.07500], -[17633, 0.76039, 0.98396, 0.03964], -[17634, 0.97082, 0.84413, 0.17828], -[17635, 0.81504, 0.98302, 0.14221], -[17636, 0.95594, 0.90754, 0.35434], -[17637, 0.96267, 0.81914, 0.09866], -[17638, 0.96189, 0.88791, 0.28675], -[17639, 0.82679, 1.00000, 0.22500], -[17640, 0.84889, 0.90890, 0.03901], -[17641, 0.79654, 0.98404, 0.10436], -[17642, 0.87010, 1.00000, 0.45000], -[17643, 0.92220, 0.95273, 0.46137], -[17644, 0.89145, 0.98210, 0.47856], -[17645, 0.92041, 0.95304, 0.43368], -[17646, 0.87931, 0.94817, 0.20331], -[17647, 0.98326, 0.89040, 0.47337], -[17648, 0.77882, 0.96550, 0.02920], -[17649, 0.97560, 0.77795, 0.04895], -[17650, 0.89637, 0.91502, 0.15397], -[17651, 0.93301, 0.80000, 0.00000], -[17652, 0.91395, 0.95786, 0.41219], -[17653, 0.93500, 0.83085, 0.05701], -[17654, 1.00000, 0.78146, 0.11250], -[17655, 1.00000, 0.86806, 0.41250], -[17656, 0.90500, 0.93069, 0.22430], -[17657, 0.98042, 0.78436, 0.07009], -[17658, 0.98132, 0.82287, 0.15190], -[17659, 0.89270, 0.93117, 0.18806], -[17660, 0.97236, 0.85414, 0.20559], -[17661, 0.80514, 1.00000, 0.16250], -[17662, 0.98194, 0.83946, 0.19449], -[17663, 0.87155, 0.90070, 0.06234], -[17664, 0.83330, 0.92570, 0.04053], -[17665, 0.87010, 1.00000, 0.42500], -[17666, 0.98034, 0.88054, 0.33785], -[17667, 0.98548, 0.88974, 0.49232], -[17668, 0.82476, 0.91250, 0.00000], -[17669, 1.00000, 0.82476, 0.21250], -[17670, 0.87713, 0.90643, 0.08517], -[17671, 0.89874, 0.88177, 0.07804], -[17672, 0.87276, 0.99098, 0.35971], -[17673, 0.96437, 0.90573, 0.38554], -[17674, 0.86529, 0.89242, 0.03269], -[17675, 0.88971, 0.85000, 0.00000], -[17676, 0.95407, 0.85801, 0.15677], -[17677, 0.93747, 0.87121, 0.14424], -[17678, 0.94860, 0.92987, 0.49077], -[17679, 0.98380, 0.83075, 0.17333], -[17680, 0.84845, 1.00000, 0.28750], -[17681, 1.00000, 0.73797, 0.03036], -[17682, 0.77795, 0.98531, 0.06488], -[17683, 0.98142, 0.89320, 0.43268], -[17684, 1.00000, 0.87500, 0.50000], -[17685, 0.87500, 1.00000, 0.50000], -[17686, 0.97631, 0.75000, 0.00000], -[17687, 0.90852, 0.96924, 0.47038], -[17688, 0.89661, 0.85875, 0.02621], -[17689, 0.98125, 0.76694, 0.03619], -[17690, 1.00000, 0.86806, 0.38750], -[17691, 0.93609, 0.94326, 0.48070], -[17692, 0.91926, 0.94167, 0.31378], -[17693, 0.90857, 0.92351, 0.20278], -[17694, 0.96409, 0.83789, 0.13211], -[17695, 1.00000, 0.84641, 0.27500], -[17696, 0.87010, 1.00000, 0.40000], -[17697, 0.95741, 0.88772, 0.24959], -[17698, 1.00000, 0.80311, 0.15000], -[17699, 0.88467, 0.98318, 0.36404], -[17700, 0.95265, 0.86674, 0.16981], -[17701, 0.94916, 0.83337, 0.08453], -[17702, 0.89749, 0.97442, 0.38019], -[17703, 0.94213, 0.85047, 0.10159], -[17704, 0.82985, 0.97254, 0.13177], -[17705, 0.80215, 0.94746, 0.02133], -[17706, 0.86808, 0.96547, 0.20837], -[17707, 0.92500, 0.95670, 0.50000], -[17708, 0.97542, 0.90399, 0.45205], -[17709, 0.98313, 0.80559, 0.10548], -[17710, 0.95364, 0.84739, 0.12083], -[17711, 0.93228, 0.93882, 0.35566], -[17712, 0.87684, 0.89374, 0.04850], -[17713, 0.76184, 1.00000, 0.06250], -[17714, 0.93660, 0.86704, 0.12171], -[17715, 0.97625, 0.89597, 0.37145], -[17716, 0.91758, 0.86482, 0.07277], -[17717, 1.00000, 0.86806, 0.36250], -[17718, 0.87010, 1.00000, 0.37500], -[17719, 0.96341, 0.81424, 0.07383], -[17720, 0.82027, 0.97382, 0.11036], -[17721, 0.86788, 0.93050, 0.10746], -[17722, 0.82570, 0.96117, 0.09035], -[17723, 0.82679, 1.00000, 0.20000], -[17724, 0.87966, 0.87897, 0.02328], -[17725, 0.92316, 0.83175, 0.02063], -[17726, 0.78349, 1.00000, 0.10000], -[17727, 0.82069, 0.93396, 0.02233], -[17728, 0.93726, 0.93719, 0.36867], -[17729, 0.73937, 1.00000, 0.02315], -[17730, 0.79418, 0.98397, 0.08151], -[17731, 0.89675, 0.89782, 0.09523], -[17732, 0.87111, 0.94618, 0.15302], -[17733, 0.87028, 0.95509, 0.17544], -[17734, 0.89172, 0.96649, 0.28561], -[17735, 1.00000, 0.72500, 0.00000], -[17736, 0.72500, 1.00000, 0.00000], -[17737, 0.90914, 0.95717, 0.31820], -[17738, 0.94192, 0.89946, 0.21801], -[17739, 0.89367, 0.97228, 0.32080], -[17740, 0.94889, 0.88017, 0.18213], -[17741, 0.89900, 0.97062, 0.33918], -[17742, 0.84845, 1.00000, 0.26250], -[17743, 0.85323, 0.94449, 0.10470], -[17744, 0.85053, 0.90580, 0.01785], -[17745, 0.84641, 0.90000, 0.00000], -[17746, 0.90893, 0.95137, 0.28723], -[17747, 0.91569, 0.87794, 0.09084], -[17748, 0.91660, 0.90416, 0.15483], -[17749, 0.92267, 0.91996, 0.21856], -[17750, 0.89945, 0.95582, 0.26680], -[17751, 0.97271, 0.84500, 0.15799], -[17752, 0.90259, 0.90902, 0.13089], -[17753, 0.93800, 0.89741, 0.19658], -[17754, 0.84539, 0.97655, 0.16991], -[17755, 0.95015, 0.91254, 0.29513], -[17756, 0.90059, 0.97793, 0.39959], -[17757, 1.00000, 0.82476, 0.18750], -[17758, 0.88103, 0.98947, 0.34736], -[17759, 0.88426, 0.92272, 0.11874], -[17760, 0.87557, 0.98170, 0.27970], -[17761, 1.00000, 0.84641, 0.25000], -[17762, 0.87010, 1.00000, 0.35000], -[17763, 0.80514, 1.00000, 0.13750], -[17764, 0.91752, 0.96286, 0.39586], -[17765, 1.00000, 0.75981, 0.05000], -[17766, 1.00000, 0.86806, 0.33750], -[17767, 0.98871, 0.84893, 0.21385], -[17768, 0.92937, 0.94350, 0.33694], -[17769, 0.81676, 0.94930, 0.03895], -[17770, 0.90884, 0.97474, 0.43130], -[17771, 1.00000, 0.78146, 0.08750], -[17772, 0.90152, 0.98302, 0.45340], -[17773, 0.92880, 0.92773, 0.25906], -[17774, 0.95466, 0.78750, 0.00000], -[17775, 0.97910, 0.90318, 0.41297], -[17776, 0.91136, 0.83750, 0.00000], -[17777, 0.96634, 0.87678, 0.21789], -[17778, 0.88152, 0.99396, 0.36852], -[17779, 0.90905, 0.94605, 0.25290], -[17780, 0.93000, 0.91113, 0.20426], -[17781, 0.76056, 0.97693, 0.00000], -[17782, 0.83807, 0.96020, 0.10181], -[17783, 0.87253, 0.98118, 0.25694], -[17784, 0.98584, 0.76078, 0.01744], -[17785, 0.97549, 0.77988, 0.02607], -[17786, 0.96454, 0.91965, 0.40871], -[17787, 0.84526, 0.94529, 0.08001], -[17788, 0.93598, 0.85202, 0.07287], -[17789, 0.95410, 0.93462, 0.46899], -[17790, 0.86238, 0.97126, 0.18711], -[17791, 0.98523, 0.87906, 0.29553], -[17792, 0.78316, 0.96865, 0.01661], -[17793, 0.92176, 0.85871, 0.05472], -[17794, 0.92038, 0.89856, 0.13824], -[17795, 0.94688, 0.92978, 0.34382], -[17796, 0.93432, 0.95212, 0.42230], -[17797, 1.00000, 0.80311, 0.12500], -[17798, 0.88320, 0.94512, 0.16474], -[17799, 0.96211, 0.92595, 0.44742], -[17800, 0.90760, 0.85096, 0.01209], -[17801, 0.91881, 0.84787, 0.02792], -[17802, 0.94645, 0.93907, 0.40609], -[17803, 0.90677, 0.87491, 0.05375], -[17804, 0.96480, 0.81001, 0.05285], -[17805, 0.94811, 0.94051, 0.43652], -[17806, 0.92695, 0.93819, 0.28056], -[17807, 0.87010, 1.00000, 0.32500], -[17808, 0.96864, 0.86653, 0.18582], -[17809, 0.83148, 0.98372, 0.14098], -[17810, 0.86641, 0.91348, 0.04951], -[17811, 0.92915, 0.89569, 0.15000], -[17812, 0.88021, 0.95814, 0.19132], -[17813, 0.81182, 0.97275, 0.07203], -[17814, 0.98813, 0.86653, 0.25238], -[17815, 0.97685, 0.91345, 0.50000], -[17816, 1.00000, 0.86806, 0.31250], -[17817, 0.84845, 1.00000, 0.23750], -[17818, 0.97447, 0.87802, 0.23796], -[17819, 0.82679, 1.00000, 0.17500], -[17820, 0.78038, 0.96458, 0.00000], -[17821, 0.94117, 0.92428, 0.27761], -[17822, 0.91250, 0.97835, 0.50000], -[17823, 0.96009, 0.89100, 0.22730], -[17824, 0.85237, 0.95879, 0.11972], -[17825, 0.87588, 0.97610, 0.23428], -[17826, 0.92283, 0.96072, 0.37362], -[17827, 0.96042, 0.92278, 0.37067], -[17828, 0.76464, 0.98578, 0.01564], -[17829, 1.00000, 0.88912, 0.47685], -[17830, 0.93547, 0.87169, 0.10480], -[17831, 0.86806, 0.88750, 0.00000], -[17832, 0.93719, 0.89802, 0.17364], -[17833, 0.96130, 0.84169, 0.10142], -[17834, 0.96831, 0.85106, 0.14014], -[17835, 0.98005, 0.80109, 0.06502], -[17836, 0.89177, 0.93053, 0.13896], -[17837, 1.00000, 0.84641, 0.22500], -[17838, 0.95256, 0.86719, 0.13578], -[17839, 0.86884, 0.93077, 0.08656], -[17840, 0.90181, 0.94510, 0.20671], -[17841, 0.90163, 0.93202, 0.16692], -[17842, 0.93615, 0.95099, 0.38959], -[17843, 0.93770, 0.93485, 0.29899], -[17844, 0.95736, 0.81505, 0.03851], -[17845, 0.88816, 0.97034, 0.24761], -[17846, 1.00000, 0.88971, 0.45000], -[17847, 1.00000, 0.82476, 0.16250], -[17848, 0.92655, 0.92998, 0.23341], -[17849, 0.78349, 1.00000, 0.07500], -[17850, 0.86055, 0.96704, 0.15535], -[17851, 0.93883, 0.92049, 0.24297], -[17852, 0.89384, 0.88652, 0.04132], -[17853, 0.98125, 0.83198, 0.12500], -[17854, 0.98203, 0.88823, 0.29414], -[17855, 0.94089, 0.95345, 0.46325], -[17856, 0.94937, 0.90861, 0.23723], -[17857, 0.85975, 0.93237, 0.06687], -[17858, 0.93139, 0.96365, 0.47931], -[17859, 0.81246, 0.96753, 0.05224], -[17860, 0.82724, 0.98605, 0.12560], -[17861, 0.87010, 1.00000, 0.30000], -[17862, 1.00000, 0.88971, 0.42500], -[17863, 0.97709, 0.90093, 0.32390], -[17864, 0.80311, 0.95000, 0.00000], -[17865, 0.94532, 0.85847, 0.09107], -[17866, 0.80514, 1.00000, 0.11250], -[17867, 0.79451, 0.97987, 0.04496], -[17868, 0.95633, 0.92186, 0.31515], -[17869, 1.00000, 0.86806, 0.28750], -[17870, 0.89312, 1.00000, 0.46458], -[17871, 0.89175, 1.00000, 0.43750], -[17872, 0.91138, 0.97393, 0.35821], -[17873, 0.91871, 0.96367, 0.33433], -[17874, 0.97824, 0.88614, 0.25906], -[17875, 0.89846, 0.91440, 0.10353], -[17876, 0.92329, 0.91501, 0.16691], -[17877, 0.84716, 0.92452, 0.02226], -[17878, 0.93301, 0.82500, 0.00000], -[17879, 0.88995, 0.96231, 0.21156], -[17880, 0.76203, 1.00000, 0.03036], -[17881, 1.00000, 0.88971, 0.40000], -[17882, 0.85880, 0.98719, 0.20055], -[17883, 1.00000, 0.78146, 0.06250], -[17884, 0.83170, 0.95537, 0.05530], -[17885, 0.98639, 0.85360, 0.18268], -[17886, 0.84845, 1.00000, 0.21250], -[17887, 0.81509, 0.98542, 0.09089], -[17888, 0.89175, 1.00000, 0.41250], -[17889, 0.96459, 0.90386, 0.26424], -[17890, 0.95867, 0.89251, 0.20415], -[17891, 0.98403, 0.81349, 0.08393], -[17892, 0.98401, 0.89381, 0.30913], -[17893, 0.97631, 0.77500, 0.00000], -[17894, 0.96623, 0.80004, 0.02013], -[17895, 0.97186, 0.91438, 0.34683], -[17896, 0.92303, 0.97499, 0.45354], -[17897, 0.98763, 0.89648, 0.33966], -[17898, 1.00000, 0.80311, 0.10000], -[17899, 0.88517, 0.94406, 0.13906], -[17900, 0.95306, 0.94686, 0.48014], -[17901, 0.89522, 0.94939, 0.17962], -[17902, 0.97626, 0.86108, 0.16696], -[17903, 0.93721, 0.84407, 0.03649], -[17904, 0.90086, 0.90264, 0.07632], -[17905, 0.98019, 0.91714, 0.43693], -[17906, 1.00000, 0.76063, 0.02315], -[17907, 0.82679, 1.00000, 0.15000], -[17908, 0.98342, 0.91028, 0.39753], -[17909, 0.89868, 0.89520, 0.05574], -[17910, 1.00000, 0.84641, 0.20000], -[17911, 0.87323, 0.89823, 0.01255], -[17912, 0.95296, 0.83074, 0.04308], -[17913, 0.85565, 0.93053, 0.04273], -[17914, 0.88971, 0.87500, 0.00000], -[17915, 1.00000, 0.88971, 0.37500], -[17916, 0.87010, 1.00000, 0.27500], -[17917, 0.98567, 0.87161, 0.22348], -[17918, 0.89175, 1.00000, 0.38750], -[17919, 0.97902, 0.79843, 0.03914], -[17920, 0.90927, 0.97054, 0.29986], -[17921, 0.98022, 0.91997, 0.45975], -[17922, 0.93154, 0.84059, 0.01556], -[17923, 0.82476, 0.93750, 0.00000], -[17924, 0.90896, 0.95314, 0.22700], -[17925, 0.85195, 0.97526, 0.13572], -[17926, 1.00000, 0.86806, 0.26250], -[17927, 1.00000, 0.90000, 0.50000], -[17928, 0.90000, 1.00000, 0.50000], -[17929, 0.80727, 0.96815, 0.02988], -[17930, 0.91869, 0.88167, 0.06526], -[17931, 0.98392, 0.91762, 0.48382], -[17932, 0.86921, 0.96012, 0.13528], -[17933, 0.96103, 0.83423, 0.06278], -[17934, 0.97424, 0.92800, 0.47992], -[17935, 0.91449, 0.97961, 0.37751], -[17936, 0.88208, 0.92276, 0.07382], -[17937, 1.00000, 0.82476, 0.13750], -[17938, 0.94554, 0.92665, 0.25690], -[17939, 0.95314, 0.88578, 0.15509], -[17940, 0.97967, 0.84045, 0.11786], -[17941, 1.00000, 0.75000, 0.00000], -[17942, 0.75000, 1.00000, 0.00000], -[17943, 0.92829, 0.89578, 0.11462], -[17944, 0.97129, 0.92574, 0.38892], -[17945, 0.94735, 0.82693, 0.01860], -[17946, 0.97102, 0.91166, 0.30242], -[17947, 0.93956, 0.96279, 0.44239], -[17948, 0.91475, 0.93685, 0.18514], -[17949, 0.86842, 0.91478, 0.02814], -[17950, 0.98421, 0.82879, 0.10239], -[17951, 0.96544, 0.93609, 0.42621], -[17952, 0.94734, 0.94082, 0.32328], -[17953, 1.00000, 0.88971, 0.35000], -[17954, 0.89175, 1.00000, 0.36250], -[17955, 0.93619, 0.95736, 0.35348], -[17956, 0.97261, 0.83337, 0.08259], -[17957, 0.83919, 0.93750, 0.01875], -[17958, 0.88543, 0.90928, 0.04821], -[17959, 0.92679, 0.97465, 0.42123], -[17960, 0.92304, 0.93850, 0.21244], -[17961, 0.96964, 0.93575, 0.50000], -[17962, 0.78349, 1.00000, 0.05000], -[17963, 0.95580, 0.94275, 0.38102], -[17964, 0.94948, 0.94434, 0.34615], -[17965, 0.95883, 0.94602, 0.44702], -[17966, 0.91678, 0.87145, 0.03394], -[17967, 0.94334, 0.92239, 0.22283], -[17968, 0.84845, 1.00000, 0.18750], -[17969, 0.89321, 0.98128, 0.26156], -[17970, 0.92334, 0.98211, 0.47675], -[17971, 0.95000, 0.95670, 0.50000], -[17972, 0.98563, 0.89495, 0.28596], -[17973, 0.80514, 1.00000, 0.08750], -[17974, 0.88469, 0.94530, 0.12288], -[17975, 0.88118, 0.98030, 0.21453], -[17976, 0.87010, 1.00000, 0.25000], -[17977, 0.98198, 0.91648, 0.37546], -[17978, 0.89527, 0.92044, 0.08626], -[17979, 0.85297, 0.94705, 0.05765], -[17980, 0.93461, 0.86792, 0.06009], -[17981, 0.88194, 0.96070, 0.15372], -[17982, 0.93935, 0.96442, 0.40794], -[17983, 0.98247, 0.87628, 0.20342], -[17984, 0.95466, 0.81250, 0.00000], -[17985, 0.89175, 1.00000, 0.33750], -[17986, 0.89984, 0.97025, 0.23436], -[17987, 0.85108, 0.98824, 0.15234], -[17988, 0.84641, 0.92500, 0.00000], -[17989, 1.00000, 0.84641, 0.17500], -[17990, 1.00000, 0.88971, 0.32500], -[17991, 1.00000, 0.86806, 0.23750], -[17992, 0.91220, 0.97907, 0.32181], -[17993, 0.92544, 0.95460, 0.26502], -[17994, 0.78666, 0.98172, 0.00937], -[17995, 0.93888, 0.87565, 0.08117], -[17996, 0.86175, 0.95075, 0.07855], -[17997, 0.82679, 1.00000, 0.12500], -[17998, 0.82304, 0.95639, 0.01803], -[17999, 0.96157, 0.85327, 0.08566], -[18000, 0.91136, 0.86250, 0.00000], -[18001, 0.96855, 0.88246, 0.17179], -[18002, 1.00000, 0.78038, 0.03542], -[18003, 0.93660, 0.90877, 0.15053], -[18004, 0.84587, 0.97934, 0.11182], -[18005, 0.97056, 0.87205, 0.14914], -[18006, 1.00000, 0.80311, 0.07500], -[18007, 0.90987, 0.89042, 0.04713], -[18008, 0.87377, 0.95578, 0.11377], -[18009, 0.88205, 0.96913, 0.16968], -[18010, 0.91242, 0.97170, 0.27714], -[18011, 0.93859, 0.91895, 0.18209], -[18012, 0.84049, 0.94918, 0.03111], -[18013, 0.89558, 0.89108, 0.01910], -[18014, 0.89649, 0.95146, 0.15583], -[18015, 0.97463, 0.90062, 0.24160], -[18016, 0.86591, 0.98375, 0.16798], -[18017, 0.96975, 0.81807, 0.03291], -[18018, 0.95929, 0.94211, 0.35833], -[18019, 0.91102, 0.98531, 0.33464], -[18020, 0.95112, 0.91410, 0.20290], -[18021, 0.95524, 0.90439, 0.18662], -[18022, 0.92781, 0.85920, 0.02065], -[18023, 0.92245, 0.98416, 0.40289], -[18024, 0.92649, 0.89211, 0.08156], -[18025, 0.94048, 0.95288, 0.30687], -[18026, 0.95760, 0.95254, 0.42442], -[18027, 0.89175, 1.00000, 0.31250], -[18028, 1.00000, 0.82476, 0.11250], -[18029, 0.96758, 0.94094, 0.40605], -[18030, 1.00000, 0.88971, 0.30000], -[18031, 0.96530, 0.93411, 0.33431], -[18032, 1.00000, 0.91169, 0.46964], -[18033, 0.87010, 1.00000, 0.22500], -[18034, 0.98155, 0.82397, 0.06365], -[18035, 0.87708, 0.98243, 0.18629], -[18036, 0.92869, 0.96258, 0.29055], -[18037, 0.96296, 0.86619, 0.10526], -[18038, 0.84642, 0.96542, 0.06978], -[18039, 0.91184, 0.97051, 0.25422], -[18040, 0.84845, 1.00000, 0.16250], -[18041, 0.86009, 0.96625, 0.09942], -[18042, 0.94566, 0.96084, 0.37115], -[18043, 1.00000, 0.91136, 0.43750], -[18044, 0.90453, 0.93423, 0.12096], -[18045, 0.93698, 0.93208, 0.20304], -[18046, 0.91345, 1.00000, 0.47685], -[18047, 0.93823, 0.94316, 0.24422], -[18048, 0.96463, 0.90958, 0.22159], -[18049, 0.80226, 0.98178, 0.02257], -[18050, 0.94885, 0.85703, 0.05195], -[18051, 0.93750, 0.97835, 0.50000], -[18052, 0.86806, 0.91250, 0.00000], -[18053, 1.00000, 0.86806, 0.21250], -[18054, 0.93805, 0.94761, 0.25851], -[18055, 0.92437, 0.95699, 0.24273], -[18056, 0.98116, 0.89239, 0.22132], -[18057, 0.95692, 0.93851, 0.29945], -[18058, 0.93579, 0.97384, 0.38730], -[18059, 0.91340, 1.00000, 0.45000], -[18060, 0.93652, 0.86356, 0.03720], -[18061, 0.98613, 0.91914, 0.35870], -[18062, 0.87501, 0.95104, 0.09085], -[18063, 0.84365, 0.97841, 0.08898], -[18064, 1.00000, 0.91136, 0.41250], -[18065, 0.94001, 0.97656, 0.46064], -[18066, 1.00000, 0.84641, 0.15000], -[18067, 0.88890, 0.94169, 0.09705], -[18068, 0.78349, 1.00000, 0.02500], -[18069, 0.93768, 0.89218, 0.09466], -[18070, 0.80514, 1.00000, 0.06250], -[18071, 0.91340, 1.00000, 0.42500], -[18072, 0.97364, 0.89185, 0.18882], -[18073, 0.89175, 1.00000, 0.28750], -[18074, 0.94149, 0.96232, 0.33179], -[18075, 0.97660, 0.92424, 0.31724], -[18076, 0.98972, 0.79168, 0.01511], -[18077, 0.89924, 0.98445, 0.24673], -[18078, 0.97188, 0.92067, 0.27650], -[18079, 0.97358, 0.86885, 0.12661], -[18080, 1.00000, 0.88971, 0.27500], -[18081, 0.92670, 0.91693, 0.12171], -[18082, 0.94190, 0.85051, 0.01813], -[18083, 0.93301, 0.85000, 0.00000], -[18084, 0.97631, 0.80000, 0.00000], -[18085, 1.00000, 0.91136, 0.38750], -[18086, 0.82679, 1.00000, 0.10000], -[18087, 0.96106, 0.90024, 0.16881], -[18088, 0.90802, 0.94291, 0.13876], -[18089, 0.91340, 1.00000, 0.40000], -[18090, 0.98045, 0.93822, 0.44607], -[18091, 0.96174, 0.94146, 0.31741], -[18092, 0.95083, 0.88949, 0.11329], -[18093, 0.96971, 0.95088, 0.47090], -[18094, 0.91172, 0.88334, 0.01632], -[18095, 0.80311, 0.97500, 0.00000], -[18096, 0.83217, 0.97825, 0.05713], -[18097, 0.92496, 0.93065, 0.14764], -[18098, 0.92195, 0.91281, 0.09614], -[18099, 0.94691, 0.94917, 0.27863], -[18100, 0.94424, 0.90434, 0.12952], -[18101, 0.89585, 0.93307, 0.08344], -[18102, 0.89295, 0.91052, 0.03059], -[18103, 0.87064, 0.93367, 0.03401], -[18104, 0.98814, 0.87538, 0.17714], -[18105, 0.87010, 1.00000, 0.20000], -[18106, 1.00000, 0.80311, 0.05000], -[18107, 0.95491, 0.87790, 0.09341], -[18108, 0.92932, 0.97384, 0.31055], -[18109, 0.98470, 0.93731, 0.49027], -[18110, 0.95509, 0.96730, 0.47297], -[18111, 0.91356, 0.91868, 0.08754], -[18112, 0.96275, 0.88776, 0.13433], -[18113, 1.00000, 0.91136, 0.36250], -[18114, 0.88128, 0.94321, 0.07160], -[18115, 0.91340, 1.00000, 0.37500], -[18116, 1.00000, 0.82476, 0.08750], -[18117, 0.86749, 0.97605, 0.11883], -[18118, 1.00000, 0.77500, 0.00000], -[18119, 0.77500, 1.00000, 0.00000], -[18120, 1.00000, 0.86806, 0.18750], -[18121, 0.84845, 1.00000, 0.13750], -[18122, 0.94188, 0.94200, 0.22255], -[18123, 0.98687, 0.93247, 0.40996], -[18124, 0.98230, 0.85008, 0.09502], -[18125, 0.88971, 0.90000, 0.00000], -[18126, 0.89175, 1.00000, 0.26250], -[18127, 0.90075, 0.97090, 0.18734], -[18128, 0.95557, 0.96306, 0.39174], -[18129, 0.83253, 0.97197, 0.03644], -[18130, 0.91924, 0.90386, 0.06322], -[18131, 0.87294, 0.98156, 0.14260], -[18132, 0.95510, 0.86779, 0.06643], -[18133, 0.97799, 0.93841, 0.37286], -[18134, 0.98078, 0.82893, 0.04752], -[18135, 0.93361, 0.98238, 0.36848], -[18136, 1.00000, 0.88971, 0.25000], -[18137, 0.93751, 0.98614, 0.44102], -[18138, 0.93216, 0.98052, 0.34222], -[18139, 0.96043, 0.92947, 0.23702], -[18140, 0.96071, 0.83597, 0.01657], -[18141, 1.00000, 0.92500, 0.50000], -[18142, 0.92500, 1.00000, 0.50000], -[18143, 0.91540, 0.95206, 0.16593], -[18144, 0.88440, 0.91639, 0.01570], -[18145, 0.82476, 0.96250, 0.00000], -[18146, 0.98434, 0.91986, 0.29571], -[18147, 0.91340, 1.00000, 0.35000], -[18148, 0.93120, 0.94180, 0.17940], -[18149, 1.00000, 0.91136, 0.33750], -[18150, 1.00000, 0.84641, 0.12500], -[18151, 0.97599, 0.81925, 0.01537], -[18152, 0.81981, 0.98647, 0.03798], -[18153, 0.96163, 0.94069, 0.27625], -[18154, 0.95961, 0.96826, 0.45211], -[18155, 0.95625, 0.90655, 0.14581], -[18156, 0.98687, 0.94165, 0.46694], -[18157, 0.98798, 0.92703, 0.33803], -[18158, 0.97201, 0.92631, 0.25660], -[18159, 0.89489, 0.98448, 0.19637], -[18160, 0.92073, 0.96777, 0.22072], -[18161, 0.90335, 0.98333, 0.21787], -[18162, 0.87010, 1.00000, 0.17500], -[18163, 0.80429, 1.00000, 0.03542], -[18164, 0.95466, 0.83750, 0.00000], -[18165, 0.97208, 0.90898, 0.19700], -[18166, 0.95330, 0.85929, 0.03442], -[18167, 0.89175, 1.00000, 0.23750], -[18168, 0.82679, 1.00000, 0.07500], -[18169, 0.97230, 0.83412, 0.02704], -[18170, 0.91340, 1.00000, 0.32500], -[18171, 0.94451, 0.98627, 0.48079], -[18172, 0.88166, 0.94207, 0.05232], -[18173, 0.92726, 0.94314, 0.15950], -[18174, 0.89795, 0.96342, 0.13805], -[18175, 1.00000, 0.91136, 0.31250], -[18176, 0.97500, 0.95670, 0.50000], -[18177, 0.94501, 0.96909, 0.31508], -[18178, 0.91778, 0.96167, 0.18496], -[18179, 0.97427, 0.95232, 0.39831], -[18180, 1.00000, 0.88971, 0.22500], -[18181, 1.00000, 0.86806, 0.16250], -[18182, 0.92930, 0.97260, 0.25883], -[18183, 0.85071, 0.96757, 0.04386], -[18184, 0.91136, 0.88750, 0.00000], -[18185, 0.97361, 0.89482, 0.15378], -[18186, 0.84641, 0.95000, 0.00000], -[18187, 0.92466, 0.98518, 0.29113], -[18188, 0.82294, 0.97935, 0.01738], -[18189, 0.98699, 0.88261, 0.15920], -[18190, 0.84845, 1.00000, 0.11250], -[18191, 0.89113, 0.97696, 0.15111], -[18192, 0.98021, 0.85243, 0.07227], -[18193, 1.00000, 0.80311, 0.02500], -[18194, 0.94012, 0.98641, 0.38224], -[18195, 0.98159, 0.94135, 0.35483], -[18196, 0.95384, 0.97714, 0.42109], -[18197, 1.00000, 0.93301, 0.47500], -[18198, 0.97937, 0.95147, 0.41785], -[18199, 1.00000, 0.82476, 0.06250], -[18200, 0.91769, 0.93331, 0.10117], -[18201, 0.97284, 0.96238, 0.48661], -[18202, 0.95126, 0.97272, 0.35231], -[18203, 1.00000, 0.93301, 0.45000], -[18204, 0.94343, 0.91041, 0.10739], -[18205, 0.95898, 0.94502, 0.25386], -[18206, 0.95346, 0.93147, 0.18890], -[18207, 0.86385, 0.97556, 0.08076], -[18208, 0.89389, 0.94015, 0.06266], -[18209, 0.91340, 1.00000, 0.30000], -[18210, 0.93254, 0.88350, 0.02605], -[18211, 0.98960, 0.83765, 0.05947], -[18212, 0.91388, 0.89989, 0.02025], -[18213, 0.86764, 0.96440, 0.06105], -[18214, 1.00000, 0.91136, 0.28750], -[18215, 0.95851, 0.93446, 0.21052], -[18216, 0.96853, 0.96011, 0.37302], -[18217, 1.00000, 0.93301, 0.42500], -[18218, 1.00000, 0.84641, 0.10000], -[18219, 0.93220, 0.95927, 0.20464], -[18220, 0.95965, 0.95535, 0.29291], -[18221, 0.93575, 1.00000, 0.46964], -[18222, 0.93458, 0.97576, 0.27269], -[18223, 0.97347, 0.86968, 0.08375], -[18224, 0.91414, 0.91251, 0.04257], -[18225, 0.89175, 1.00000, 0.21250], -[18226, 0.91700, 0.98350, 0.23562], -[18227, 0.93505, 1.00000, 0.43750], -[18228, 0.96827, 0.95786, 0.34649], -[18229, 0.97966, 0.93964, 0.31010], -[18230, 0.86814, 0.95575, 0.03978], -[18231, 0.91502, 0.97636, 0.20239], -[18232, 0.95172, 0.92691, 0.16179], -[18233, 0.87010, 1.00000, 0.15000], -[18234, 0.84288, 0.96797, 0.01811], -[18235, 0.95359, 0.88984, 0.07709], -[18236, 1.00000, 0.93301, 0.40000], -[18237, 0.98164, 0.92068, 0.23652], -[18238, 0.93153, 0.89769, 0.04483], -[18239, 0.93900, 0.96232, 0.22973], -[18240, 0.93216, 0.92737, 0.11002], -[18241, 0.97506, 0.85403, 0.05157], -[18242, 1.00000, 0.88971, 0.20000], -[18243, 0.90726, 0.97386, 0.16790], -[18244, 0.88258, 0.97088, 0.09958], -[18245, 0.93505, 1.00000, 0.41250], -[18246, 0.89350, 0.98785, 0.17119], -[18247, 0.86806, 0.93750, 0.00000], -[18248, 0.96118, 0.86832, 0.04688], -[18249, 0.96918, 0.95544, 0.32308], -[18250, 0.92715, 0.93894, 0.12277], -[18251, 0.97631, 0.82500, 0.00000], -[18252, 0.94228, 0.89792, 0.06429], -[18253, 0.94230, 0.98993, 0.37275], -[18254, 0.95307, 0.98317, 0.40298], -[18255, 0.91340, 1.00000, 0.27500], -[18256, 1.00000, 0.86806, 0.13750], -[18257, 0.98075, 0.95968, 0.44963], -[18258, 0.95436, 0.98558, 0.43768], -[18259, 0.82679, 1.00000, 0.05000], -[18260, 0.93301, 0.87500, 0.00000], -[18261, 1.00000, 0.93301, 0.37500], -[18262, 0.97668, 0.83139, 0.00906], -[18263, 0.96458, 0.97779, 0.50000], -[18264, 0.91097, 0.92859, 0.05865], -[18265, 0.93505, 1.00000, 0.38750], -[18266, 1.00000, 0.91136, 0.26250], -[18267, 0.98621, 0.88501, 0.13757], -[18268, 0.94410, 0.96501, 0.24529], -[18269, 0.89982, 0.93003, 0.03863], -[18270, 0.97381, 0.88637, 0.10518], -[18271, 0.92851, 0.94929, 0.14415], -[18272, 1.00000, 0.80000, 0.00000], -[18273, 0.80000, 1.00000, 0.00000], -[18274, 0.84845, 1.00000, 0.08750], -[18275, 0.99233, 0.95140, 0.48202], -[18276, 0.91866, 0.93371, 0.08202], -[18277, 0.91488, 0.95569, 0.12538], -[18278, 0.86959, 0.94976, 0.01766], -[18279, 0.97072, 0.97218, 0.43238], -[18280, 0.90394, 0.95796, 0.10346], -[18281, 0.95336, 0.98386, 0.37658], -[18282, 0.91710, 0.96287, 0.14748], -[18283, 0.93829, 0.99086, 0.32558], -[18284, 0.89175, 1.00000, 0.18750], -[18285, 1.00000, 0.93301, 0.35000], -[18286, 0.93505, 1.00000, 0.36250], -[18287, 0.94280, 0.91213, 0.08450], -[18288, 0.94620, 0.97732, 0.29243], -[18289, 0.88958, 0.98444, 0.13500], -[18290, 0.98495, 0.90453, 0.17485], -[18291, 1.00000, 0.82476, 0.03750], -[18292, 0.93210, 0.97773, 0.23662], -[18293, 0.95933, 0.89984, 0.09464], -[18294, 0.85613, 0.98427, 0.06096], -[18295, 0.98233, 0.93967, 0.28412], -[18296, 0.88461, 0.96574, 0.07611], -[18297, 0.94163, 0.95422, 0.18604], -[18298, 0.95809, 0.97508, 0.33522], -[18299, 0.98125, 0.91858, 0.20000], -[18300, 0.91340, 1.00000, 0.25000], -[18301, 1.00000, 0.84641, 0.07500], -[18302, 0.89269, 0.93101, 0.01682], -[18303, 0.88971, 0.92500, 0.00000], -[18304, 1.00000, 0.88971, 0.17500], -[18305, 0.94761, 0.92624, 0.12349], -[18306, 0.87010, 1.00000, 0.12500], -[18307, 0.96841, 0.92485, 0.17598], -[18308, 0.95968, 0.98790, 0.46366], -[18309, 0.97307, 0.97148, 0.41184], -[18310, 0.95993, 0.95187, 0.23196], -[18311, 0.98198, 0.92290, 0.21124], -[18312, 1.00000, 0.91136, 0.23750], -[18313, 0.90543, 0.95118, 0.08121], -[18314, 0.85697, 0.96986, 0.02552], -[18315, 0.89865, 0.97289, 0.11735], -[18316, 0.93505, 1.00000, 0.33750], -[18317, 1.00000, 0.93301, 0.32500], -[18318, 0.98763, 0.94698, 0.32867], -[18319, 0.94474, 0.94112, 0.14878], -[18320, 0.99114, 0.83111, 0.02135], -[18321, 0.97614, 0.97383, 0.46699], -[18322, 1.00000, 0.95000, 0.50000], -[18323, 0.95000, 1.00000, 0.50000], -[18324, 0.96105, 0.96238, 0.26874], -[18325, 1.00000, 0.86806, 0.11250], -[18326, 0.84202, 0.98479, 0.02551], -[18327, 0.96706, 0.98429, 0.48485], -[18328, 0.97050, 0.88879, 0.08441], -[18329, 0.94936, 0.94551, 0.16870], -[18330, 0.94978, 0.98331, 0.30989], -[18331, 0.95466, 0.86250, 0.00000], -[18332, 0.96649, 0.88298, 0.06228], -[18333, 0.95715, 0.88294, 0.04158], -[18334, 0.97376, 0.91709, 0.15633], -[18335, 0.97287, 0.85154, 0.01415], -[18336, 0.88809, 0.94832, 0.03119], -[18337, 0.89175, 1.00000, 0.16250], -[18338, 0.82679, 1.00000, 0.02500], -[18339, 0.93505, 1.00000, 0.31250], -[18340, 0.91340, 1.00000, 0.22500], -[18341, 1.00000, 0.93301, 0.30000], -[18342, 1.00000, 0.95389, 0.46458], -[18343, 0.84845, 1.00000, 0.06250], -[18344, 0.97755, 0.93702, 0.22083], -[18345, 0.91908, 0.98292, 0.18238], -[18346, 0.97999, 0.96986, 0.39391], -[18347, 0.92913, 0.96854, 0.16621], -[18348, 0.97849, 0.94277, 0.24196], -[18349, 0.92827, 0.94891, 0.11137], -[18350, 0.93483, 0.97847, 0.21383], -[18351, 0.91136, 0.91250, 0.00000], -[18352, 1.00000, 0.91136, 0.21250], -[18353, 1.00000, 0.88971, 0.15000], -[18354, 0.97113, 0.90648, 0.11318], -[18355, 0.97917, 0.94908, 0.26403], -[18356, 1.00000, 0.95466, 0.43750], -[18357, 0.96160, 0.92816, 0.14032], -[18358, 0.95670, 1.00000, 0.47500], -[18359, 0.84641, 0.97500, 0.00000], -[18360, 0.87010, 1.00000, 0.10000], -[18361, 0.95670, 1.00000, 0.45000], -[18362, 0.91658, 0.94235, 0.06438], -[18363, 0.93176, 0.92117, 0.05120], -[18364, 0.98659, 0.88058, 0.08836], -[18365, 1.00000, 0.84641, 0.05000], -[18366, 0.96182, 0.98707, 0.35990], -[18367, 1.00000, 0.95466, 0.41250], -[18368, 0.94424, 0.89587, 0.02579], -[18369, 0.93505, 1.00000, 0.28750], -[18370, 0.97799, 0.93420, 0.19938], -[18371, 0.91303, 0.92451, 0.01851], -[18372, 0.95670, 1.00000, 0.42500], -[18373, 1.00000, 0.93301, 0.27500], -[18374, 0.93497, 0.97563, 0.19104], -[18375, 0.86917, 0.97847, 0.04297], -[18376, 0.83705, 0.99089, 0.00981], -[18377, 0.97487, 0.98476, 0.44709], -[18378, 0.95079, 0.96519, 0.20402], -[18379, 1.00000, 0.86806, 0.08750], -[18380, 0.96101, 0.87744, 0.01989], -[18381, 1.00000, 0.95466, 0.38750], -[18382, 0.91340, 1.00000, 0.20000], -[18383, 0.94197, 0.95763, 0.15357], -[18384, 0.95670, 1.00000, 0.40000], -[18385, 0.90617, 0.96714, 0.08894], -[18386, 0.97631, 0.85000, 0.00000], -[18387, 0.90344, 0.96060, 0.06784], -[18388, 0.88784, 0.96555, 0.04637], -[18389, 0.88400, 0.98656, 0.08572], -[18390, 0.89175, 1.00000, 0.13750], -[18391, 0.97771, 0.86468, 0.02722], -[18392, 0.91211, 0.98054, 0.13426], -[18393, 0.97733, 0.91467, 0.13064], -[18394, 1.00000, 0.91136, 0.18750], -[18395, 0.99003, 0.96248, 0.35210], -[18396, 0.97931, 0.93234, 0.18328], -[18397, 0.96847, 0.97817, 0.31497], -[18398, 0.94737, 0.98508, 0.25211], -[18399, 0.93340, 0.91324, 0.02598], -[18400, 1.00000, 0.95466, 0.36250], -[18401, 0.93301, 0.90000, 0.00000], -[18402, 1.00000, 0.82500, 0.00000], -[18403, 0.82500, 1.00000, 0.00000], -[18404, 0.93505, 1.00000, 0.26250], -[18405, 0.92488, 0.95383, 0.09308], -[18406, 0.95670, 1.00000, 0.37500], -[18407, 0.90566, 0.95108, 0.04572], -[18408, 1.00000, 0.88971, 0.12500], -[18409, 1.00000, 0.93301, 0.25000], -[18410, 0.84845, 1.00000, 0.03750], -[18411, 0.92248, 0.93368, 0.03944], -[18412, 0.96839, 0.95536, 0.20919], -[18413, 0.97117, 0.96363, 0.24816], -[18414, 0.95683, 0.92842, 0.10257], -[18415, 0.86922, 0.96458, 0.00000], -[18416, 0.98365, 0.96935, 0.33022], -[18417, 0.87768, 0.98662, 0.06096], -[18418, 0.98824, 0.84892, 0.01075], -[18419, 0.97649, 0.98903, 0.42511], -[18420, 0.96893, 0.93930, 0.15887], -[18421, 0.95319, 0.97709, 0.22755], -[18422, 0.87010, 1.00000, 0.07500], -[18423, 0.98071, 0.97917, 0.36906], -[18424, 0.95670, 1.00000, 0.35000], -[18425, 1.00000, 0.95466, 0.33750], -[18426, 0.87991, 0.96889, 0.02508], -[18427, 0.93207, 0.96359, 0.12302], -[18428, 0.91340, 1.00000, 0.17500], -[18429, 0.95146, 0.90897, 0.04321], -[18430, 0.99623, 0.86292, 0.04882], -[18431, 0.94341, 0.93999, 0.09090], -[18432, 0.93056, 0.91383, 0.00937], -[18433, 1.00000, 0.84641, 0.02500], -[18434, 0.96849, 0.90748, 0.07502], -[18435, 0.93505, 1.00000, 0.23750], -[18436, 0.90411, 0.98174, 0.09688], -[18437, 0.88971, 0.95000, 0.00000], -[18438, 0.96657, 0.98092, 0.28112], -[18439, 1.00000, 0.91136, 0.16250], -[18440, 0.85778, 0.98752, 0.01672], -[18441, 1.00000, 0.86806, 0.06250], -[18442, 0.92580, 0.98345, 0.15237], -[18443, 0.89175, 1.00000, 0.11250], -[18444, 0.95157, 0.94530, 0.11744], -[18445, 0.98957, 0.96371, 0.30574], -[18446, 0.95670, 1.00000, 0.32500], -[18447, 0.98196, 0.90344, 0.09317], -[18448, 1.00000, 0.93301, 0.22500], -[18449, 1.00000, 0.95466, 0.31250], -[18450, 0.90961, 0.94478, 0.02399], -[18451, 0.97703, 0.88249, 0.03813], -[18452, 0.96818, 0.95213, 0.17773], -[18453, 0.95466, 0.88750, 0.00000], -[18454, 0.96749, 0.92126, 0.09335], -[18455, 1.00000, 0.97500, 0.50000], -[18456, 0.97500, 1.00000, 0.50000], -[18457, 1.00000, 0.88971, 0.10000], -[18458, 0.96361, 0.98274, 0.25842], -[18459, 0.93049, 0.97720, 0.13632], -[18460, 0.91558, 0.98289, 0.11390], -[18461, 1.00000, 0.97631, 0.47500], -[18462, 0.98463, 0.99210, 0.48850], -[18463, 0.93854, 0.95854, 0.10691], -[18464, 0.95666, 0.91756, 0.05543], -[18465, 0.95670, 1.00000, 0.30000], -[18466, 1.00000, 0.97631, 0.45000], -[18467, 1.00000, 0.95466, 0.28750], -[18468, 0.91340, 1.00000, 0.15000], -[18469, 0.93505, 1.00000, 0.21250], -[18470, 0.95265, 0.96935, 0.16814], -[18471, 0.97779, 1.00000, 0.46458], -[18472, 0.97150, 0.90194, 0.05196], -[18473, 0.90065, 0.98132, 0.07071], -[18474, 0.92188, 0.96637, 0.08191], -[18475, 0.98074, 0.96049, 0.22753], -[18476, 1.00000, 0.97631, 0.42500], -[18477, 0.98335, 0.98487, 0.35143], -[18478, 0.91136, 0.93750, 0.00000], -[18479, 0.87010, 1.00000, 0.05000], -[18480, 0.93329, 0.95099, 0.07036], -[18481, 1.00000, 0.93301, 0.20000], -[18482, 0.97835, 1.00000, 0.43750], -[18483, 1.00000, 0.91136, 0.13750], -[18484, 0.98836, 0.89076, 0.06195], -[18485, 0.96672, 0.89826, 0.02980], -[18486, 0.98194, 0.97171, 0.26676], -[18487, 0.95172, 0.96219, 0.13568], -[18488, 0.99062, 0.98725, 0.40875], -[18489, 0.96078, 0.96146, 0.15771], -[18490, 0.97835, 1.00000, 0.41250], -[18491, 0.98376, 0.93284, 0.14311], -[18492, 0.89175, 1.00000, 0.08750], -[18493, 0.96822, 0.94825, 0.14059], -[18494, 0.95670, 1.00000, 0.27500], -[18495, 0.97366, 0.93585, 0.12276], -[18496, 0.99144, 0.86011, 0.00592], -[18497, 1.00000, 0.95466, 0.26250], -[18498, 0.97631, 0.87500, 0.00000], -[18499, 1.00000, 0.97835, 0.38750], -[18500, 0.97835, 1.00000, 0.38750], -[18501, 0.90242, 0.96609, 0.02864], -[18502, 0.96292, 0.97269, 0.18857], -[18503, 1.00000, 0.86922, 0.03542], -[18504, 0.97866, 0.92805, 0.10962], -[18505, 0.93505, 1.00000, 0.18750], -[18506, 1.00000, 0.88971, 0.07500], -[18507, 0.93122, 0.97650, 0.11068], -[18508, 1.00000, 0.85000, 0.00000], -[18509, 0.85000, 1.00000, 0.00000], -[18510, 0.94862, 0.93780, 0.05906], -[18511, 0.98557, 0.98125, 0.30000], -[18512, 0.91340, 1.00000, 0.12500], -[18513, 0.92441, 0.96017, 0.05429], -[18514, 1.00000, 0.97835, 0.36250], -[18515, 0.97835, 1.00000, 0.36250], -[18516, 0.93301, 0.92500, 0.00000], -[18517, 1.00000, 0.93301, 0.17500], -[18518, 0.95443, 0.91557, 0.02263], -[18519, 0.95670, 1.00000, 0.25000], -[18520, 0.94534, 0.93404, 0.03731], -[18521, 1.00000, 0.95466, 0.23750], -[18522, 0.89358, 0.98247, 0.03451], -[18523, 1.00000, 0.91136, 0.11250], -[18524, 0.90828, 0.97577, 0.04862], -[18525, 0.96600, 0.93014, 0.07223], -[18526, 0.97113, 0.98125, 0.22500], -[18527, 0.87010, 1.00000, 0.02500], -[18528, 0.96732, 0.94894, 0.11673], -[18529, 0.94530, 0.96001, 0.08973], -[18530, 1.00000, 0.97835, 0.33750], -[18531, 0.97835, 1.00000, 0.33750], -[18532, 0.98015, 0.89004, 0.01712], -[18533, 0.89175, 1.00000, 0.06250], -[18534, 0.94786, 0.98175, 0.14677], -[18535, 0.93626, 0.93690, 0.01742], -[18536, 0.93505, 1.00000, 0.16250], -[18537, 0.94931, 0.97299, 0.12298], -[18538, 0.95670, 1.00000, 0.22500], -[18539, 1.00000, 0.97835, 0.31250], -[18540, 0.97835, 1.00000, 0.31250], -[18541, 1.00000, 0.93301, 0.15000], -[18542, 0.95466, 0.91250, 0.00000], -[18543, 1.00000, 0.95466, 0.21250], -[18544, 1.00000, 0.88971, 0.05000], -[18545, 0.91340, 1.00000, 0.10000], -[18546, 0.88912, 0.97685, 0.00000], -[18547, 0.93180, 0.98006, 0.09237], -[18548, 0.97113, 0.98125, 0.20000], -[18549, 0.93311, 0.95300, 0.03302], -[18550, 0.98343, 0.98300, 0.24682], -[18551, 0.97948, 0.91823, 0.05795], -[18552, 0.98596, 0.92162, 0.07972], -[18553, 0.98473, 0.96551, 0.18761], -[18554, 1.00000, 1.00000, 0.50000], -[18555, 0.98566, 0.95323, 0.15347], -[18556, 1.00000, 1.00000, 0.47500], -[18557, 1.00000, 0.91136, 0.08750], -[18558, 0.97835, 1.00000, 0.28750], -[18559, 1.00000, 0.97835, 0.28750], -[18560, 1.00000, 1.00000, 0.45000], -[18561, 0.92443, 0.96650, 0.03519], -[18562, 0.95670, 1.00000, 0.20000], -[18563, 1.00000, 1.00000, 0.42500], -[18564, 0.93505, 1.00000, 0.13750], -[18565, 0.97418, 0.97381, 0.16879], -[18566, 0.89734, 0.98248, 0.01339], -[18567, 0.93824, 0.96246, 0.05039], -[18568, 1.00000, 0.95466, 0.18750], -[18569, 1.00000, 1.00000, 0.40000], -[18570, 1.00000, 0.93301, 0.12500], -[18571, 0.97781, 0.94120, 0.08852], -[18572, 0.95096, 0.97441, 0.10163], -[18573, 0.97631, 0.90000, 0.00000], -[18574, 0.96950, 0.97110, 0.13902], -[18575, 0.89312, 1.00000, 0.03542], -[18576, 0.97835, 1.00000, 0.26250], -[18577, 0.91340, 1.00000, 0.07500], -[18578, 0.97595, 0.92229, 0.03916], -[18579, 1.00000, 0.87500, 0.00000], -[18580, 0.87500, 1.00000, 0.00000], -[18581, 1.00000, 1.00000, 0.37500], -[18582, 1.00000, 0.97631, 0.25000], -[18583, 0.98801, 0.90894, 0.03659], -[18584, 0.96822, 0.93674, 0.05035], -[18585, 1.00000, 0.88912, 0.02315], -[18586, 0.92700, 0.96050, 0.01349], -[18587, 0.98668, 0.95236, 0.12629], -[18588, 0.96420, 0.97168, 0.11694], -[18589, 0.95670, 1.00000, 0.17500], -[18590, 0.91169, 0.96964, 0.00000], -[18591, 1.00000, 0.91136, 0.06250], -[18592, 1.00000, 1.00000, 0.35000], -[18593, 0.93301, 0.95000, 0.00000], -[18594, 0.93505, 1.00000, 0.11250], -[18595, 1.00000, 0.95466, 0.16250], -[18596, 0.96797, 0.96082, 0.09294], -[18597, 0.97835, 1.00000, 0.23750], -[18598, 0.99104, 0.98076, 0.21250], -[18599, 0.94832, 0.96843, 0.06332], -[18600, 0.92959, 0.98234, 0.05370], -[18601, 1.00000, 0.97631, 0.22500], -[18602, 0.91398, 0.98593, 0.02883], -[18603, 0.96720, 0.95247, 0.06704], -[18604, 1.00000, 0.93301, 0.10000], -[18605, 1.00000, 1.00000, 0.32500], -[18606, 0.94225, 0.98397, 0.07901], -[18607, 0.98967, 0.94724, 0.10416], -[18608, 0.98478, 0.91278, 0.01886], -[18609, 0.91340, 1.00000, 0.05000], -[18610, 0.95670, 1.00000, 0.15000], -[18611, 0.97835, 1.00000, 0.21250], -[18612, 1.00000, 1.00000, 0.30000], -[18613, 0.95466, 0.93750, 0.00000], -[18614, 0.96742, 0.93290, 0.01584], -[18615, 0.95880, 0.95727, 0.04621], -[18616, 1.00000, 0.95466, 0.13750], -[18617, 0.98580, 0.93917, 0.06492], -[18618, 1.00000, 0.97631, 0.20000], -[18619, 0.93505, 1.00000, 0.08750], -[18620, 0.98391, 0.96288, 0.10913], -[18621, 1.00000, 1.00000, 0.27500], -[18622, 1.00000, 0.93301, 0.07500], -[18623, 1.00000, 0.91169, 0.03036], -[18624, 0.97835, 1.00000, 0.18750], -[18625, 0.96285, 0.97530, 0.07973], -[18626, 0.95670, 1.00000, 0.12500], -[18627, 0.93385, 0.98239, 0.03167], -[18628, 0.96013, 0.94687, 0.01066], -[18629, 0.97631, 0.92500, 0.00000], -[18630, 1.00000, 0.97631, 0.17500], -[18631, 0.92112, 0.98478, 0.00898], -[18632, 1.00000, 0.90000, 0.00000], -[18633, 0.90000, 1.00000, 0.00000], -[18634, 1.00000, 0.95466, 0.11250], -[18635, 0.91345, 1.00000, 0.02315], -[18636, 1.00000, 1.00000, 0.25000], -[18637, 0.98816, 0.93572, 0.03921], -[18638, 0.95451, 0.96346, 0.02452], -[18639, 0.93505, 1.00000, 0.06250], -[18640, 0.98516, 0.96482, 0.09018], -[18641, 0.97835, 1.00000, 0.16250], -[18642, 0.93301, 0.97500, 0.00000], -[18643, 0.96994, 0.95345, 0.02874], -[18644, 1.00000, 0.93301, 0.05000], -[18645, 0.95670, 1.00000, 0.10000], -[18646, 1.00000, 1.00000, 0.22500], -[18647, 1.00000, 0.97631, 0.15000], -[18648, 0.95316, 0.97939, 0.04373], -[18649, 0.98269, 0.93492, 0.01404], -[18650, 0.97711, 0.97914, 0.09308], -[18651, 0.98148, 0.95546, 0.04931], -[18652, 0.98379, 0.98337, 0.11949], -[18653, 0.98265, 0.96514, 0.07256], -[18654, 1.00000, 0.95466, 0.08750], -[18655, 0.95559, 0.99021, 0.06385], -[18656, 0.97010, 0.97340, 0.05803], -[18657, 0.97835, 1.00000, 0.13750], -[18658, 1.00000, 1.00000, 0.20000], -[18659, 0.95389, 0.96458, 0.00000], -[18660, 1.00000, 0.97631, 0.12500], -[18661, 0.95670, 1.00000, 0.07500], -[18662, 1.00000, 0.93301, 0.02500], -[18663, 0.93575, 1.00000, 0.03036], -[18664, 1.00000, 0.95466, 0.06250], -[18665, 0.94634, 0.98663, 0.01437], -[18666, 1.00000, 0.92500, 0.00000], -[18667, 0.92500, 1.00000, 0.00000], -[18668, 1.00000, 1.00000, 0.17500], -[18669, 0.97631, 0.95000, 0.00000], -[18670, 0.98867, 0.94783, 0.01977], -[18671, 0.97306, 0.97161, 0.03532], -[18672, 0.97835, 1.00000, 0.11250], -[18673, 1.00000, 0.97631, 0.10000], -[18674, 0.95670, 1.00000, 0.05000], -[18675, 0.97432, 0.96577, 0.01315], -[18676, 1.00000, 1.00000, 0.15000], -[18677, 1.00000, 0.95389, 0.03542], -[18678, 0.98255, 0.98546, 0.06501], -[18679, 0.96247, 0.98440, 0.01946], -[18680, 0.97835, 1.00000, 0.08750], -[18681, 1.00000, 0.97631, 0.07500], -[18682, 1.00000, 1.00000, 0.12500], -[18683, 0.95670, 1.00000, 0.02500], -[18684, 0.97835, 1.00000, 0.06250], -[18685, 0.98628, 0.98615, 0.04555], -[18686, 1.00000, 0.95000, 0.00000], -[18687, 0.95000, 1.00000, 0.00000], -[18688, 0.97631, 0.97500, 0.00000], -[18689, 1.00000, 0.97631, 0.05000], -[18690, 1.00000, 1.00000, 0.10000], -[18691, 0.98540, 0.98439, 0.02077], -[18692, 0.97779, 1.00000, 0.03542], -[18693, 1.00000, 0.97631, 0.02500], -[18694, 1.00000, 1.00000, 0.07500], -[18695, 1.00000, 0.97500, 0.00000], -[18696, 0.97500, 1.00000, 0.00000], -[18697, 1.00000, 1.00000, 0.05000], -[18698, 1.00000, 1.00000, 0.02500], -[18699, 1.00000, 1.00000, 0.00000] -]) - diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.prb b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.prb deleted file mode 100644 index f54441733ea6..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.prb +++ /dev/null @@ -1,8 +0,0 @@ -PROBLEM DATA -QUESTION: END_TIME -VALUE: 0.1 -QUESTION: DELTA_TIME -VALUE: 0.001 -END PROBLEM DATA -INTERVAL DATA -END INTERVAL DATA diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.prop b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.prop deleted file mode 100644 index ed7457a9a846..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.prop +++ /dev/null @@ -1,3 +0,0 @@ -PROPERTIES[1][END_TIME] = 0.1; -PROPERTIES[1][DELTA_TIME] = 0.001; - diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.py b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.py deleted file mode 100644 index 3927a2360647..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.py +++ /dev/null @@ -1,150 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# -# -# setting the domain size for the problem to be solved -domain_size = 3 - -# -# -# ATTENTION: here the order is important - -# including kratos path -kratos_path = '../../../../' # kratos_root/ -import sys -sys.path.append(kratos_path) - -# importing Kratos main library -from KratosMultiphysics import * - -# importing applications -from KratosMultiphysics.IncompressibleFluidApplicationimport * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * - -# from now on the order is not anymore crucial -# -# - -import math - -# defining a model part -model_part = ModelPart("FluidPart") - -# adding of Variables to Model Part should be here when the "very fix container will be ready" -import pfem_solver_ale -pfem_solver_ale.AddVariables(model_part) - -# reading a model -gid_mode_flag = GiDPostMode.GiD_PostBinary -use_multifile = MultiFileFlag.MultipleFiles -deformed_print_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteConditions -gid_io = GidIO("dam3d", gid_mode_flag, use_multifile, deformed_print_flag, write_conditions) -gid_io.ReadModelPart(model_part) - -print model_part - -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(2) - -# importing the solver files -pfem_solver_ale.AddDofs(model_part) - -# for node in model_part.Nodes: -# node.GetSolutionStepValue(TEMPERATURE); - -# setting the limits of the bounding box -box_corner1 = Vector(3) -box_corner1[0] = -0.01 -box_corner1[1] = -0.01 -box_corner1[2] = -0.01 -box_corner2 = Vector(3) -box_corner2[0] = 1.01 -box_corner2[1] = 1.01 -box_corner2[2] = 1.01 - -# creating a fluid solver object -name = str("dam3d") - -solver = pfem_solver_ale.PFEMSolver(model_part, name, box_corner1, box_corner2, domain_size) -solver.predictor_corrector = True -solver.prediction_order = 1; -solver.max_vel_its = 5; -solver.max_press_its = 3; -solver.set_echo_level = 0; -# pDiagPrecond = DiagonalPreconditioner() -# solver.pressure_linear_solver = CGSolver(1e-4, 5000,pDiagPrecond) -# solver.pressure_linear_solver = SkylineLUFactorizationSolver() - -g = Array3() -g[2] = -9.81; -for node in model_part.Nodes: - node.SetSolutionStepValue(VISCOSITY, 0, 0.000001) - node.SetSolutionStepValue(DENSITY, 0, 1000.000) - node.SetSolutionStepValue(BODY_FORCE, 0, g) - -Dt = 0.005 -nsteps = 6 -output_Dt = 0.1 -min_dt = Dt -max_dt = 10 * Dt -tmax = 20.00 - -# initializing the solver -solver.Initialize(Dt, output_Dt) - -scalarout = open("pressure_history.out", 'w') -scalarout.write("time (0.0,0.093) (0.0,0.299) \n") - - -time = 0.0 -step = 0 -new_Dt = 0.00 -# for step in range(0,nsteps): -while (time < tmax): - step = step + 1 - - new_Dt = solver.EstimateDeltaTime(min_dt, max_dt) - if(step <= 3): - new_Dt = 0.000001 - # step = step + 1 - time = time + new_Dt - print "time = ", time, " new_Dt= ", new_Dt, " step = ", step - - # time = Dt*step - model_part.CloneTimeStep(time) - - print time - # print model_part.ProcessInfo()[TIME] - - # solving the fluid problem - -# solver.Remesh() -# solver.OutputStep(time,gid_io); - - print " step = ", step - if(step > 3): - solver.Solve(time, gid_io) -# else: -# print "remeshing" -# print "printing" -# solver.OutputStep(time,gid_io) - - -# -# chapuza to identify the effect of the mesh motion -# solver.close_result_file = False -# for node in model_part.Nodes: -# vel = node.GetSolutionStepValue(VELOCITY); -# mesh_vel = node.GetSolutionStepValue(MESH_VELOCITY); -# temp = (vel[0]-mesh_vel[0])**2 + (vel[1]-mesh_vel[1])**2 + (vel[2]-mesh_vel[2])**2 -# denom = (vel[0])**2 + (vel[1])**2 + (vel[2])**2 -# -# if (denom < 0.000001): -# node.SetSolutionStepValue(TEMPERATURE,0,0.00); -# else: -# node.SetSolutionStepValue(TEMPERATURE,0,temp/denom); -# -# gid_io.WriteNodalResults(TEMPERATURE, model_part.Nodes, time, 0); -# gid_io.Flush() -# gid_io.CloseResultFile(); diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.rdr b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.rdr deleted file mode 100644 index 1e739896822c..000000000000 Binary files a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.rdr and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.uni b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.uni deleted file mode 100644 index 0468052e4eaa..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d.uni +++ /dev/null @@ -1,2 +0,0 @@ -model: m -problem: INTERNATIONAL diff --git a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d_onlyfluid.py b/applications/PFEMapplication/test_examples/dam3d.gid/dam3d_onlyfluid.py deleted file mode 100644 index 950fdf12ffac..000000000000 --- a/applications/PFEMapplication/test_examples/dam3d.gid/dam3d_onlyfluid.py +++ /dev/null @@ -1,101 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# -# -# setting the domain size for the problem to be solved -domain_size = 3 - -# -# -# ATTENTION: here the order is important - -# including kratos path -kratos_libs_path = '../../../../libs/' # kratos_root/libs -kratos_applications_path = '../../../../applications/' # kratos_root/applications -import sys -sys.path.append(kratos_libs_path) -sys.path.append(kratos_applications_path) - -# importing Kratos main library -from Kratos import * -kernel = Kernel() # defining kernel - -# importing applications -import applications_interface -applications_interface.Import_IncompressibleFluidApplication = True -applications_interface.ImportApplications(kernel, kratos_applications_path) - -# from now on the order is not anymore crucial -# -# - -from KratosIncompressibleFluidApplication import * - - -# defining a model part -model_part = ModelPart("FluidPart") - -# adding of Variables to Model Part should be here when the "very fix container will be ready" - -# reading a model -gid_io = GidIO("dam3d", GiDPostMode.GiD_PostBinary) -gid_io.ReadMesh(model_part.GetMesh()) -gid_io.WriteMesh((model_part).GetMesh(), domain_size, GiDPostMode.GiD_PostBinary) -print(model_part) - -g = Array3() -g[2] = -9.81 -for node in model_part.Nodes: - node.SetSolutionStepValue(VISCOSITY, 0, 0.000001) - node.SetSolutionStepValue(DENSITY, 0, 1.000) - node.SetSolutionStepValue(BODY_FORCE, 0, g) - -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(3) - -# importing the solver files -import incompressible_fluid_solver -incompressible_fluid_solver.AddVariables(model_part) - - -# creating a fluid solver object -fluid_solver = incompressible_fluid_solver.IncompressibleFluidSolver(model_part, domain_size) -fluid_solver.predictor_corrector = True -fluid_solver.laplacian_form = 2 -fluid_solver.vel_toll = 1e-3 -fluid_solver.time_order = 0 - -pILUPrecond = ILU0Preconditioner() -fluid_solver.pressure_linear_solver = BICGSTABSolver(1e-3, 5000, pILUPrecond) - - -fluid_solver.Initialize() - -# settings to be changed -Re = 100.0 -nsteps = 100 -output_step = 1 - - -Dt = 0.001 -out = 0 - - -for step in range(0, nsteps): - print("line49") - - time = Dt * step - model_part.CloneTimeStep(time) - - print(time) - # print model_part.ProcessInfo()[TIME] - - # solving the fluid problem - if(step > 4): - fluid_solver.Solve() - - # print the results - if(out == output_step): - gid_io.WriteNodalResults(PRESSURE, model_part.Nodes, time, 0) - gid_io.WriteNodalResults(VELOCITY, model_part.Nodes, time, 0) - out = 0 - out = out + 1 diff --git a/applications/PFEMapplication/test_examples/pfem_benchmarks.py b/applications/PFEMapplication/test_examples/pfem_benchmarks.py deleted file mode 100644 index 942ed48c7772..000000000000 --- a/applications/PFEMapplication/test_examples/pfem_benchmarks.py +++ /dev/null @@ -1,103 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import os -import sys - -kratos_benchmarking_path = '../../../benchmarking' -sys.path.append(kratos_benchmarking_path) -import benchmarking - - -def Run(): - Msg = "" - Text = "== PFEM ==========\n" - -# dam2d -# -# Text += "dam_2d: " -# os.chdir("dam2d.gid") -# sys.path.append(os.getcwd()) -# -# print "running the pfem dam2d benchmark test..." -# successful,Msg = benchmarking.RunBenchmark("dam2d.py","dam2d_ref.txt") -# -# if (Msg == True): -# Text += "OK\n" -# print "pfem dam2d test example successful" -# else: -# Text += "FAILED\n" -# Text += Msg -# Text += "\n\n" -# print "pfem dam2d test example FAILED" -# -# -# os.chdir("..") - - # - # dam 2D NON-NEWTONIAN - Text += "dam_2d_Non-Newtonian: " - os.chdir("dam2dNonNewt_Y1500.gid") - sys.path.append(os.getcwd()) - - print("running the dam2dNonNewt benchmark test...") - successful,Msg = benchmarking.RunBenchmark("dam2dNonNewt.py", "dam2dNonNewt_ref.txt") - - if(successful==True): - Text += "OK\n" - print("dam2dNonNewt example successful") - else: - Text += "FAILED\n" - Text += Msg - Text += "\n\n" - print("dam2dNonNewt example FAILED") - - os.chdir("..") - # - # slope 2D NON-NEWTONIAN COUPLED - - Text += "coupled_slope_2d_Non-Newtonian: " - os.chdir("Coupled_slope2dNonNewt.gid") - sys.path.append(os.getcwd()) - - print("running the CoupledNonNewtSlope benchmark test...") - successful,Msg = benchmarking.RunBenchmark("CoupledNonNewtSlope.py", "CoupledNonNewtSlope_ref.txt") - - if(successful==True): - Text += "OK\n" - print("CoupledNonNewtSlope example successful") - else: - Text += "FAILED\n" - Text += Msg - Text += "\n\n" - print("CoupledNonNewtSlope example FAILED") - - os.chdir("..") - # - # slope 2D COUETTE NON-NEWTONIAN - - Text += "COUETTE_2d_Non-Newtonian: " - os.chdir("CouetteNonNewtonian2d.gid") - sys.path.append(os.getcwd()) - - print("running the Couette2dNonNewt benchmark test...") - successful,Msg = benchmarking.RunBenchmark("Couette2dNonNewt.py", "Couette2dNonNewt_ref.txt") - - if(successful==True): - Text += "OK\n" - print("Couette2dNonNewt example successful") - else: - Text += "FAILED\n" - Text += Msg - Text += "\n\n" - print("Couette2dNonNewt example FAILED") - - os.chdir("..") - # - - # Add other examples here - # - print("resume of all of the examples for the pfem application :") - print(Text) - return Text - -if __name__ == '__main__': - Run() diff --git a/applications/PFEMapplication/test_examples/pfem_build_references.py b/applications/PFEMapplication/test_examples/pfem_build_references.py deleted file mode 100644 index 35df20559c65..000000000000 --- a/applications/PFEMapplication/test_examples/pfem_build_references.py +++ /dev/null @@ -1,12 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -import os - -# dam2d - -os.chdir("dam2d.gid") - -import dam2d_build_reference - -os.chdir("..") - -# Add other examples here diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_hist_veryfine.csv b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_hist_veryfine.csv deleted file mode 100644 index 10fa71464b5e..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_hist_veryfine.csv +++ /dev/null @@ -1,8004 +0,0 @@ -time (0.0,0.093) (0.0,0.299) -1e-06 0.0 0.0 -2e-06 0.0 0.0 -3e-06 0.0 0.0 -0.002503 7.04136336228 0.0 -0.005003 23.3100424077 0.0 -0.007503 19.4715118741 0.0 -0.010003 18.7851894737 0.0 -0.012503 19.0049947361 0.0 -0.015003 19.8000960599 0.0 -0.017503 20.7697769285 0.0 -0.020003 21.737068936 0.0 -0.022503 23.172884782 0.0 -0.025003 24.3900226502 0.0 -0.027503 25.7986673078 0.0 -0.030003 27.3083064727 0.0 -0.032503 28.7555289956 0.0 -0.035003 30.0527571297 0.0 -0.037503 31.436452336 0.0 -0.040003 32.6576262696 0.0 -0.042503 33.8434677356 0.0 -0.045003 34.8563531388 0.0 -0.047503 35.5999908969 0.0 -0.050003 36.1799656037 0.0 -0.052503 36.705211262 0.0 -0.055003 37.2950530269 0.0 -0.057503 37.93801264 0.0 -0.060003 38.8963189896 0.0 -0.062503 40.227628029 0.0 -0.065003 41.7581709791 0.0 -0.067503 43.3631581019 0.0 -0.070003 44.7904934025 0.0 -0.072503 45.7839179334 0.0 -0.075003 46.3169336681 0.0 -0.077503 46.3321213667 0.0 -0.080003 46.4088428333 0.0 -0.082503 46.7185192874 0.0 -0.085003 47.3651665813 0.0 -0.087503 48.1749151233 0.0 -0.090003 48.971933322 0.0 -0.092503 49.7078298353 0.0 -0.095003 50.4418897405 0.0 -0.097503 51.0333757694 0.0 -0.100003 51.6319387646 0.0 -0.102503 52.873502362 0.0 -0.105003 53.7914942941 0.0 -0.107503 54.7524480257 0.0 -0.110003 55.7025920784 0.0 -0.112503 56.5069927045 0.0 -0.115003 57.2792433705 0.0 -0.117503 57.9717438785 0.0 -0.120003 58.6285855773 0.0 -0.122503 59.3192172245 0.0 -0.125003 59.9855862673 0.0 -0.127503 60.714084068 0.0 -0.130003 61.1702281508 0.0 -0.132503 61.576625947 0.0 -0.135003 62.05262049 0.0 -0.137503 62.6609539119 0.0 -0.140003 63.8452834603 0.0 -0.142503 64.8465703591 0.0 -0.145003 65.8007635239 0.0 -0.147503 66.7513863746 0.0 -0.150003 67.7455543908 0.0 -0.152503 68.7315818144 0.0 -0.155003 69.6539880961 0.0 -0.157503 70.5727298904 0.0 -0.160003 71.4974582897 0.0 -0.162503 71.13387268 0.0 -0.165003 70.6706971068 0.0 -0.167503 70.4453315413 0.0 -0.170003 70.5397263919 0.0 -0.172503 70.92916946 0.0 -0.175003 71.5192294044 0.0 -0.177503 71.9182534849 0.0 -0.180003 72.2660678293 0.0 -0.182503 72.7382026189 0.0 -0.185003 73.1288943299 0.0 -0.187503 73.4957999279 0.0 -0.190003 73.9522764056 0.0 -0.192503 73.5138656387 0.0 -0.195003 75.5827678662 0.0 -0.197503 76.013503233 0.0 -0.200003 76.3744583992 0.0 -0.202503 78.1572269781 0.0 -0.205003 79.9151834475 0.0 -0.207503 81.6194616242 0.0 -0.210003 83.1794043233 0.0 -0.212503 84.4738358621 0.0 -0.215003 85.5898685349 0.0 -0.217503 86.6098959132 0.0 -0.220003 87.5205914063 0.0 -0.222503 91.4580977387 0.0 -0.225003 93.4436526236 0.0 -0.227503 94.7831314027 0.0 -0.230003 95.7077765496 0.0 -0.232503 96.3846115015 0.0 -0.235003 96.9545082782 0.0 -0.237503 97.4733666155 0.0 -0.240003 97.9958539829 0.0 -0.242503 98.6099072056 0.0 -0.245003 99.2582677938 0.0 -0.247503 99.7127816573 0.0 -0.250003 100.434930721 0.0 -0.252503 101.475217402 0.0 -0.255003 101.477739985 0.0 -0.257503 101.29034767 0.0 -0.260003 101.189600694 0.0 -0.262503 101.214739679 0.0 -0.265003 100.969474234 0.0 -0.267503 101.606766637 0.0 -0.270003 102.893642896 0.0 -0.272503 104.221935762 0.0 -0.275003 105.705424148 0.0 -0.277503 107.335911602 0.0 -0.280003 108.71025431 0.0 -0.282503 110.379663829 0.0 -0.285003 111.905745815 0.0 -0.287503 113.029248033 0.0 -0.290003 114.148992241 0.0 -0.292503 115.321031126 0.0 -0.295003 116.502280245 0.0 -0.297503 117.802250177 0.0 -0.300003 119.060633771 0.0 -0.302503 120.307205492 0.0 -0.305003 121.534620679 0.0 -0.307503 122.740486614 0.0 -0.310003 124.465849675 0.0 -0.312503 125.686584654 0.0 -0.315003 126.741663952 0.0 -0.317503 127.744694613 0.0 -0.320003 128.821180708 0.0 -0.322503 129.712077415 0.0 -0.325003 130.491654702 0.0 -0.327503 131.220188303 0.0 -0.330003 131.982293488 0.0 -0.332503 132.720616435 0.0 -0.335003 133.471209006 0.0 -0.337503 134.176756264 0.0 -0.340003 135.078067449 0.0 -0.342503 136.048423886 0.0 -0.345003 136.964409025 0.0 -0.347503 137.952140539 0.0 -0.350003 138.987434742 0.0 -0.352503 140.057983018 0.0 -0.355003 141.177504518 0.0 -0.357503 142.348416752 0.0 -0.360003 143.505477849 0.0 -0.362503 144.73528058 0.0 -0.365003 145.983150037 0.0 -0.367503 147.269760281 0.0 -0.370003 148.506836115 0.0 -0.372503 149.821176154 0.0 -0.375003 151.155500424 0.0 -0.377503 152.489415797 0.0 -0.380003 153.844200068 0.0 -0.382503 155.199051964 0.0 -0.385003 156.560344133 0.0 -0.387503 157.932059053 0.0 -0.390003 159.324485848 0.0 -0.392503 160.683997125 0.0 -0.395003 162.392471725 0.0 -0.397503 163.865805859 0.0 -0.400003 165.27151843 0.0 -0.402503 166.730427958 0.0 -0.405003 168.094374482 0.0 -0.407503 169.416444077 0.0 -0.410003 170.897208578 0.0 -0.412503 172.188379129 0.0 -0.415003 173.429662149 0.0 -0.417503 174.648961531 0.0 -0.420003 175.857399063 0.0 -0.422503 177.417306032 0.0 -0.425003 178.652361089 0.0 -0.427503 179.931581539 0.0 -0.430003 181.200027506 0.0 -0.432503 182.567403878 0.0 -0.435003 183.910968392 0.0 -0.437503 185.281007775 0.0 -0.440003 186.644406035 0.0 -0.442503 187.990300673 0.0 -0.445003 189.644127085 0.0 -0.447503 191.060032679 0.0 -0.450003 192.443038334 0.0 -0.452503 193.856029302 0.0 -0.455003 195.289248486 0.0 -0.457503 196.752587211 0.0 -0.460003 198.239142165 0.0 -0.462503 199.784113814 0.0 -0.465003 201.313692143 0.0 -0.467503 203.033008038 0.0 -0.470003 204.909464755 0.0 -0.472503 206.597176362 0.0 -0.475003 208.270332232 0.0 -0.477503 209.931512757 0.0 -0.480003 211.645925251 0.0 -0.482503 213.291305036 0.0 -0.485003 214.967276187 0.0 -0.487503 216.660935697 0.0 -0.490003 218.394245777 0.0 -0.492503 220.07656188 0.0 -0.495003 221.804302454 0.0 -0.497503 223.51297123 0.0 -0.500003 225.247925617 0.0 -0.502503 227.215647239 0.0 -0.505003 228.752000967 0.0 -0.507503 229.562156723 0.0 -0.510003 230.662705768 0.0 -0.512503 232.846599532 0.0 -0.515003 234.764954427 0.0 -0.517503 236.432991618 0.0 -0.520003 237.971319233 0.0 -0.522503 239.428762803 0.0 -0.525003 240.781031095 0.0 -0.527503 242.123157632 0.0 -0.530003 243.471014474 0.0 -0.532503 244.830662915 0.0 -0.535003 246.200671334 0.0 -0.537503 247.580129086 0.0 -0.540003 249.015437872 0.0 -0.542503 250.456867463 0.0 -0.545003 251.873708646 0.0 -0.547503 253.518278079 0.0 -0.550003 254.915315369 0.0 -0.552503 256.294419587 0.0 -0.555003 257.681518237 0.0 -0.557503 259.047225057 0.0 -0.560003 260.392684009 0.0 -0.562503 261.697506856 0.0 -0.565003 263.018412139 0.0 -0.567503 264.342155208 0.0 -0.570003 265.805038763 0.0 -0.572503 267.156370575 0.0 -0.575003 268.471633273 0.0 -0.577503 269.799005848 0.0 -0.580003 271.079222638 0.0 -0.582503 272.378066961 0.0 -0.585003 273.639225971 0.0 -0.587503 274.87271695 0.0 -0.590003 276.114158004 0.0 -0.592503 277.344350221 0.0 -0.595003 278.525876983 0.0 -0.597503 279.309928486 0.0 -0.600003 280.161584036 0.0 -0.602503 281.07261405 0.0 -0.605003 282.926242892 0.0 -0.607503 283.356940165 0.0 -0.610003 285.468507803 0.0 -0.612503 285.425659698 0.0 -0.615003 288.08930848 0.0 -0.617503 289.204496009 0.0 -0.620003 290.245531341 0.0 -0.622503 290.57453267 0.0 -0.625003 292.187269451 0.0 -0.627503 293.131555598 0.0 -0.630003 294.053478139 0.0 -0.632503 294.94578154 0.0 -0.635003 295.954233792 0.0 -0.637503 296.93933942 0.0 -0.640003 297.936175581 0.0 -0.642503 298.980430121 0.0 -0.645003 300.061349012 0.0 -0.647503 301.081691587 0.0 -0.650003 302.135103695 0.0 -0.652503 303.106755409 0.0 -0.655003 304.157842521 0.0 -0.657503 305.074681504 0.0 -0.660003 305.964493173 0.0 -0.662503 306.891893598 0.0 -0.665003 307.811027186 0.0 -0.667503 308.708602247 0.0 -0.670003 309.580476273 0.0 -0.672503 310.447502483 0.0 -0.675003 311.330263205 0.0 -0.677503 311.47179812 0.0 -0.680003 313.22063715 0.0 -0.682503 313.947420057 0.0 -0.685003 314.646159824 0.0 -0.687503 315.337908128 0.0 -0.690003 316.034460034 0.0 -0.692503 316.732414464 0.0 -0.695003 317.452651228 0.0 -0.697503 318.063002629 0.0 -0.700003 318.788195677 0.0 -0.702503 319.418968494 0.0 -0.705003 320.144838438 0.0 -0.707503 320.663808786 0.0 -0.710003 321.327403259 0.0 -0.712503 321.949025112 0.0 -0.715003 322.534098471 0.0 -0.717503 322.871311596 0.0 -0.720003 323.362755626 0.0 -0.722503 323.390480762 0.0 -0.725003 324.194647484 0.0 -0.727503 324.024088553 0.0 -0.730003 325.051824309 0.0 -0.732503 325.542280209 0.0 -0.735003 325.976566139 0.0 -0.737503 326.375017661 0.0 -0.740003 326.793285664 0.0 -0.742503 327.159815819 0.0 -0.745003 327.54515946 0.0 -0.747503 327.851868207 0.0 -0.750003 328.228571174 0.0 -0.752503 328.568725351 0.0 -0.755003 328.94865553 0.0 -0.757503 329.284269844 0.0 -0.760003 329.63117712 0.0 -0.762503 329.946420831 0.0 -0.765003 330.277007749 0.0 -0.767503 330.542424253 0.0 -0.770003 330.887229434 0.0 -0.772503 331.122212469 0.0 -0.775003 331.410955036 0.0 -0.777503 331.682225119 0.0 -0.780003 331.921223825 0.0 -0.782503 332.138535657 0.0 -0.785003 332.377400178 0.0 -0.787503 332.608164062 0.0 -0.790003 332.751276765 0.0 -0.792503 332.903599054 0.0 -0.795003 333.061464236 0.0 -0.797503 333.234403909 0.0 -0.800003 333.33517299 0.0 -0.802503 333.412518251 0.0 -0.805003 333.470826158 0.0 -0.807503 333.529156098 0.0 -0.810003 333.567862884 0.0 -0.812503 333.576276229 0.0 -0.815003 333.541617474 0.0 -0.817503 333.516311471 0.0 -0.820003 333.445768253 0.0 -0.822503 333.378247748 0.0 -0.825003 333.274503485 0.0 -0.827503 333.157856888 0.0 -0.830003 333.020094509 0.0 -0.832503 332.78918295 0.0 -0.835003 332.556890056 0.0 -0.837503 332.289299059 0.0 -0.840003 331.966589961 0.0 -0.842503 331.586225117 0.0 -0.845003 331.230908138 0.0 -0.847503 330.826545593 0.0 -0.850003 330.330123707 0.0 -0.852503 329.797936561 0.0 -0.855003 329.218192134 0.0 -0.857503 328.653402178 0.0 -0.860003 328.077381707 0.0 -0.862503 327.496072295 0.0 -0.865003 326.812128766 0.0 -0.867503 326.217775611 0.0 -0.870003 325.558605843 0.0 -0.872503 324.891324573 0.0 -0.875003 324.191535373 0.0 -0.877503 323.45215336 0.0 -0.880003 322.690470261 0.0 -0.882503 321.921450053 0.0 -0.885003 321.13640994 0.0 -0.887503 320.320030039 0.0 -0.890003 319.48744409 0.0 -0.892503 318.60684022 0.0 -0.895003 317.747561302 0.0 -0.897503 316.874189348 0.0 -0.900003 316.056500799 0.0 -0.902503 315.229013457 0.0 -0.905003 314.353747672 0.0 -0.907503 313.456933828 0.0 -0.910003 312.56161718 0.0 -0.912503 311.407974926 0.0 -0.915003 310.573599381 0.0 -0.917503 308.855095493 0.0 -0.920003 307.744193288 0.0 -0.922503 306.802240251 0.0 -0.925003 305.845920118 0.0 -0.927503 305.427583864 0.0 -0.930003 303.686752295 0.0 -0.932503 302.273386465 0.0 -0.935003 301.545710971 0.0 -0.937503 299.526152486 0.0 -0.940003 299.325628692 0.0 -0.942503 298.117244903 0.0 -0.945003 296.985896922 0.0 -0.947503 295.853499277 0.0 -0.950003 294.543305486 0.0 -0.952503 292.94787322 0.0 -0.955003 292.068527999 0.0 -0.957503 290.570459287 0.0 -0.960003 290.182470297 0.0 -0.962503 289.237529563 0.0 -0.965003 288.265382957 0.0 -0.967503 287.237773938 0.0 -0.970003 286.174607876 0.0 -0.972503 285.063925791 0.0 -0.975003 284.065477548 0.0 -0.977503 283.112498972 0.0 -0.980003 282.097204463 0.0 -0.982503 281.153312565 0.0 -0.985003 280.215030502 0.0 -0.987503 279.273810463 0.0 -0.990003 278.515756677 0.0 -0.992503 276.515631217 0.0 -0.995003 274.781207986 0.0 -0.997503 273.668338672 0.0 -1.000003 272.483355361 0.0 -1.002503 271.248397901 0.0 -1.005003 271.340812781 0.0 -1.007503 269.867693991 0.0 -1.010003 268.261804331 0.0 -1.012503 268.804210813 0.0 -1.015003 267.086469824 0.0 -1.017503 264.899371864 0.0 -1.020003 262.464064523 0.0 -1.022503 259.722862215 0.0 -1.025003 256.15682948 0.0 -1.027503 255.073439083 0.0 -1.030003 252.992204426 0.0 -1.032503 251.244256386 0.0 -1.035003 248.884802373 0.0 -1.037503 246.737336309 0.0 -1.040003 243.17391077 0.0 -1.042503 240.929184414 0.0 -1.045003 238.817618209 0.0 -1.047503 236.805991121 0.0 -1.050003 234.832345651 0.0 -1.052503 232.798213064 0.0 -1.055003 230.654272236 0.0 -1.057503 228.42632875 0.0 -1.060003 226.140958101 0.0 -1.062503 223.837429954 0.0 -1.065003 221.401196926 0.0 -1.067503 218.328103517 0.0 -1.070003 215.713376255 0.0 -1.072503 213.102171135 0.0 -1.075003 210.668527696 0.0 -1.077503 208.30552034 0.0 -1.080003 205.888560595 0.0 -1.082503 203.427072447 0.0 -1.085003 200.981737346 0.0 -1.087503 198.420316026 0.0 -1.090003 196.011498388 0.0 -1.092503 193.685842006 0.0 -1.095003 191.020643767 0.0 -1.097503 188.864112144 0.0 -1.100003 186.254353297 0.0 -1.102503 183.131670483 0.0 -1.105003 181.056320319 0.0 -1.107503 179.079902005 0.0 -1.110003 175.600747489 0.0 -1.112503 172.924844191 0.0 -1.115003 170.458532761 0.0 -1.117503 168.074064098 0.0 -1.120003 165.74717049 0.0 -1.122503 163.587006895 0.0 -1.125003 161.460757865 0.0 -1.127503 159.324632519 0.0 -1.130003 157.427817681 0.0 -1.132503 155.00862397 0.0 -1.135003 152.802026747 0.0 -1.137503 150.621097757 0.0 -1.140003 151.812116637 0.0 -1.142503 149.856848237 0.0 -1.145003 147.356087389 0.0 -1.147503 144.373991952 0.0 -1.150003 141.500997194 0.0 -1.152503 138.981345477 0.0 -1.155003 136.387312734 0.0 -1.157503 134.108553061 0.0 -1.160003 128.808658088 0.0 -1.162503 126.086169769 0.0 -1.165003 124.052224367 0.0 -1.167503 122.65720938 0.0 -1.170003 121.511909774 0.0 -1.172503 121.523466938 0.0 -1.175003 118.564621028 0.0 -1.177503 116.66305319 0.0 -1.180003 114.548914051 0.0 -1.182503 112.429996106 0.0 -1.185003 110.424837814 0.0 -1.187503 107.383515909 0.0 -1.190003 103.881214735 0.0 -1.192503 100.193942803 0.0 -1.195003 96.56505025 0.0 -1.197503 93.0380200086 0.0 -1.200003 89.7000736588 0.0 -1.202503 86.519535788 0.0 -1.205003 83.446581861 0.0 -1.207503 79.821166218 0.0 -1.210003 75.855186696 0.0 -1.212503 71.1989731693 0.0 -1.215003 66.9701339742 0.0 -1.217503 63.3609178527 0.0 -1.220003 60.0115133627 0.0 -1.222503 56.8053081369 0.0 -1.225003 53.7151958696 0.0 -1.227503 51.4180270237 0.0 -1.230003 46.8747755198 0.0 -1.232503 45.2569675267 0.0 -1.235003 45.8079042267 0.0 -1.237503 46.1208023323 0.0 -1.240003 43.995051867 0.0 -1.242503 41.595318682 0.0 -1.245003 39.4236041018 0.0 -1.247503 38.3580594975 0.0 -1.250003 36.7414913646 0.0 -1.252503 34.7046844595 0.0 -1.255003 31.2370748627 0.0 -1.257503 28.9169555217 0.0 -1.260003 26.0783018366 0.0 -1.262503 21.0048452268 0.0 -1.265003 19.0012750469 0.0 -1.267503 14.5193524598 0.0 -1.270003 11.8522078858 0.0 -1.272503 12.477746883 0.0 -1.275003 11.0480669935 0.0 -1.277503 9.82686305775 0.0 -1.280003 9.02493406802 0.0 -1.282503 6.35154351846 0.0 -1.285003 -10.3093370385 0.0 -1.287503 -5.44380994368 0.0 -1.290003 -13.7484934142 0.0 -1.292503 -5.88939294276 0.0 -1.295003 -17.2011759854 0.0 -1.297503 -4.98482703864 0.0 -1.300003 -6.24185065186 0.0 -1.302503 -8.52271639747 0.0 -1.305003 -10.911192824 0.0 -1.307503 -14.2830874559 0.0 -1.310003 -17.5140791038 0.0 -1.312503 -20.0669924879 0.0 -1.315003 -21.2276382312 0.0 -1.317503 0.0 0.0 -1.320003 0.0 0.0 -1.322503 0.0 0.0 -1.325003 0.0 0.0 -1.327503 0.0 0.0 -1.330003 0.0 0.0 -1.332503 0.0 0.0 -1.335003 0.0 0.0 -1.337503 0.0 0.0 -1.340003 0.0 0.0 -1.342503 0.0 0.0 -1.345003 0.0 0.0 -1.347503 0.0 0.0 -1.350003 0.0 0.0 -1.352503 0.0 0.0 -1.355003 0.0 0.0 -1.357503 0.0 0.0 -1.360003 0.0 0.0 -1.362503 0.0 0.0 -1.365003 0.0 0.0 -1.367503 0.0 0.0 -1.370003 0.0 0.0 -1.372503 0.0 0.0 -1.375003 0.0 0.0 -1.377503 0.0 0.0 -1.380003 0.0 0.0 -1.382503 0.0 0.0 -1.385003 0.0 0.0 -1.387503 0.0 0.0 -1.390003 0.0 0.0 -1.392503 0.0 0.0 -1.395003 0.0 0.0 -1.397503 0.0 0.0 -1.400003 0.0 0.0 -1.402503 0.0 0.0 -1.405003 0.0 0.0 -1.407503 0.0 0.0 -1.410003 0.0 0.0 -1.412503 0.0 0.0 -1.415003 0.0 0.0 -1.417503 0.0 0.0 -1.420003 0.0 0.0 -1.422503 0.0 0.0 -1.425003 0.0 0.0 -1.427503 0.0 0.0 -1.430003 0.0 0.0 -1.432503 0.0 0.0 -1.435003 0.0 0.0 -1.437503 0.0 0.0 -1.440003 0.0 0.0 -1.442503 0.0 0.0 -1.445003 0.0 0.0 -1.447503 0.0 0.0 -1.450003 0.0 0.0 -1.452503 0.0 0.0 -1.455003 0.0 0.0 -1.457503 0.0 0.0 -1.460003 0.0 0.0 -1.462503 0.0 0.0 -1.465003 0.0 0.0 -1.467503 0.0 0.0 -1.470003 0.0 0.0 -1.472503 0.0 0.0 -1.475003 0.0 0.0 -1.477503 0.0 0.0 -1.480003 0.0 0.0 -1.482503 0.0 0.0 -1.485003 0.0 0.0 -1.487503 0.0 0.0 -1.490003 0.0 0.0 -1.492503 0.0 0.0 -1.495003 0.0 0.0 -1.497503 0.0 0.0 -1.500003 0.0 0.0 -1.502503 0.0 0.0 -1.505003 0.0 0.0 -1.507503 0.0 0.0 -1.510003 0.0 0.0 -1.512503 0.0 0.0 -1.515003 0.0 0.0 -1.517503 0.0 0.0 -1.520003 0.0 0.0 -1.522503 0.0 0.0 -1.525003 0.0 0.0 -1.527503 0.0 0.0 -1.530003 0.0 0.0 -1.532503 0.0 0.0 -1.535003 0.0 0.0 -1.537503 0.0 0.0 -1.540003 0.0 0.0 -1.542503 0.0 0.0 -1.545003 0.0 0.0 -1.547503 0.0 0.0 -1.550003 0.0 0.0 -1.552503 0.0 0.0 -1.555003 0.0 0.0 -1.557503 0.0 0.0 -1.560003 0.0 0.0 -1.562503 0.0 0.0 -1.565003 0.0 0.0 -1.567503 0.0 0.0 -1.570003 0.0 0.0 -1.572503 0.0 0.0 -1.575003 0.0 0.0 -1.577503 0.0 0.0 -1.580003 0.0 0.0 -1.582503 0.0 0.0 -1.585003 0.0 0.0 -1.587503 0.0 0.0 -1.590003 0.0 0.0 -1.592503 0.0 0.0 -1.595003 0.0 0.0 -1.597503 0.0 0.0 -1.600003 0.0 0.0 -1.602503 0.0 0.0 -1.605003 0.0 0.0 -1.607503 0.0 0.0 -1.610003 0.0 0.0 -1.612503 0.0 0.0 -1.615003 0.0 0.0 -1.617503 0.0 0.0 -1.620003 0.0 0.0 -1.622503 0.0 0.0 -1.625003 0.0 0.0 -1.627503 0.0 0.0 -1.630003 0.0 0.0 -1.632503 0.0 0.0 -1.635003 0.0 0.0 -1.637503 0.0 0.0 -1.640003 0.0 0.0 -1.642503 0.0 0.0 -1.645003 0.0 0.0 -1.647503 0.0 0.0 -1.650003 0.0 0.0 -1.652503 0.0 0.0 -1.655003 0.0 0.0 -1.657503 0.0 0.0 -1.660003 0.0 0.0 -1.662503 0.0 0.0 -1.665003 0.0 0.0 -1.667503 0.0 0.0 -1.670003 0.0 0.0 -1.672503 0.0 0.0 -1.675003 0.0 0.0 -1.677503 0.0 0.0 -1.680003 0.0 0.0 -1.682503 0.0 0.0 -1.685003 0.0 0.0 -1.687503 0.0 0.0 -1.690003 0.0 0.0 -1.692503 0.0 0.0 -1.695003 0.0 0.0 -1.697503 0.0 0.0 -1.700003 0.0 0.0 -1.702503 0.0 0.0 -1.705003 0.0 0.0 -1.707503 0.0 0.0 -1.710003 0.0 0.0 -1.712503 0.0 0.0 -1.715003 0.0 0.0 -1.717503 0.0 0.0 -1.720003 0.0 0.0 -1.722503 0.0 0.0 -1.725003 0.0 0.0 -1.727503 0.0 0.0 -1.730003 0.0 0.0 -1.732503 0.0 0.0 -1.735003 0.0 0.0 -1.737503 0.0 0.0 -1.740003 0.0 0.0 -1.742503 0.0 0.0 -1.745003 0.0 0.0 -1.747503 0.0 0.0 -1.750003 0.0 0.0 -1.752503 0.0 0.0 -1.755003 0.0 0.0 -1.757503 0.0 0.0 -1.760003 0.0 0.0 -1.762503 0.0 0.0 -1.765003 0.0 0.0 -1.767503 0.0 0.0 -1.770003 0.0 0.0 -1.772503 0.0 0.0 -1.775003 0.0 0.0 -1.777503 0.0 0.0 -1.780003 0.0 0.0 -1.782503 0.0 0.0 -1.785003 0.0 0.0 -1.787503 0.0 0.0 -1.790003 0.0 0.0 -1.792503 0.0 0.0 -1.795003 0.0 0.0 -1.797503 0.0 0.0 -1.800003 0.0 0.0 -1.802503 0.0 0.0 -1.805003 0.0 0.0 -1.807503 0.0 0.0 -1.810003 0.0 0.0 -1.812503 0.0 0.0 -1.815003 0.0 0.0 -1.817503 0.0 0.0 -1.820003 0.0 0.0 -1.822503 0.0 0.0 -1.825003 0.0 0.0 -1.827503 0.0 0.0 -1.830003 0.0 0.0 -1.832503 0.0 0.0 -1.835003 0.0 0.0 -1.837503 0.0 0.0 -1.840003 0.0 0.0 -1.842503 0.0 0.0 -1.845003 0.0 0.0 -1.847503 0.0 0.0 -1.850003 0.0 0.0 -1.852503 0.0 0.0 -1.855003 0.0 0.0 -1.857503 0.0 0.0 -1.860003 0.0 0.0 -1.862503 0.0 0.0 -1.865003 0.0 0.0 -1.867503 0.0 0.0 -1.870003 0.0 0.0 -1.872503 0.0 0.0 -1.875003 0.0 0.0 -1.877503 0.0 0.0 -1.880003 0.0 0.0 -1.882503 0.0 0.0 -1.885003 0.0 0.0 -1.887503 0.0 0.0 -1.890003 0.0 0.0 -1.892503 0.0 0.0 -1.895003 0.0 0.0 -1.897503 0.0 0.0 -1.900003 0.0 0.0 -1.902503 0.0 0.0 -1.905003 0.0 0.0 -1.907503 0.0 0.0 -1.910003 0.0 0.0 -1.912503 0.0 0.0 -1.915003 0.0 0.0 -1.917503 0.0 0.0 -1.920003 0.0 0.0 -1.922503 0.0 0.0 -1.925003 0.0 0.0 -1.927503 0.0 0.0 -1.930003 0.0 0.0 -1.932503 0.0 0.0 -1.935003 0.0 0.0 -1.937503 0.0 0.0 -1.940003 0.0 0.0 -1.942503 0.0 0.0 -1.945003 0.0 0.0 -1.947503 0.0 0.0 -1.950003 0.0 0.0 -1.952503 0.0 0.0 -1.955003 0.0 0.0 -1.957503 0.0 0.0 -1.960003 0.0 0.0 -1.962503 0.0 0.0 -1.965003 0.0 0.0 -1.967503 0.0 0.0 -1.970003 0.0 0.0 -1.972503 0.0 0.0 -1.975003 0.0 0.0 -1.977503 0.0 0.0 -1.980003 0.0 0.0 -1.982503 0.0 0.0 -1.985003 0.0 0.0 -1.987503 0.0 0.0 -1.990003 0.0 0.0 -1.992503 0.0 0.0 -1.995003 0.0 0.0 -1.997503 0.0 0.0 -2.000003 0.0 0.0 -2.002503 0.0 0.0 -2.005003 0.0 0.0 -2.007503 0.0 0.0 -2.010003 0.0 0.0 -2.012503 0.0 0.0 -2.015003 0.0 0.0 -2.017503 0.0 0.0 -2.020003 0.0 0.0 -2.022503 0.0 0.0 -2.025003 0.0 0.0 -2.027503 0.0 0.0 -2.030003 0.0 0.0 -2.032503 0.0 0.0 -2.035003 0.0 0.0 -2.037503 0.0 0.0 -2.040003 0.0 0.0 -2.042503 0.0 0.0 -2.045003 0.0 0.0 -2.047503 0.0 0.0 -2.050003 0.0 0.0 -2.052503 0.0 0.0 -2.055003 0.0 0.0 -2.057503 0.0 0.0 -2.060003 0.0 0.0 -2.062503 0.0 0.0 -2.065003 0.0 0.0 -2.067503 0.0 0.0 -2.070003 0.0 0.0 -2.072503 0.0 0.0 -2.075003 0.0 0.0 -2.077503 0.0 0.0 -2.080003 0.0 0.0 -2.082503 0.0 0.0 -2.085003 0.0 0.0 -2.087503 0.0 0.0 -2.090003 0.0 0.0 -2.092503 0.0 0.0 -2.095003 0.0 0.0 -2.097503 0.0 0.0 -2.100003 0.0 0.0 -2.102503 0.0 0.0 -2.105003 0.0 0.0 -2.107503 0.0 0.0 -2.110003 0.0 0.0 -2.112503 0.0 0.0 -2.115003 0.0 0.0 -2.117503 0.0 0.0 -2.120003 0.0 0.0 -2.122503 0.0 0.0 -2.125003 0.0 0.0 -2.127503 0.0 0.0 -2.130003 0.0 0.0 -2.132503 0.0 0.0 -2.135003 0.0 0.0 -2.137503 0.0 0.0 -2.140003 0.0 0.0 -2.142503 0.0 0.0 -2.145003 0.0 0.0 -2.147503 0.0 0.0 -2.150003 0.0 0.0 -2.152503 0.0 0.0 -2.155003 0.0 0.0 -2.157503 0.0 0.0 -2.160003 0.0 0.0 -2.162503 0.0 0.0 -2.165003 0.0 0.0 -2.167503 0.0 0.0 -2.170003 0.0 0.0 -2.172503 0.0 0.0 -2.175003 0.0 0.0 -2.177503 0.0 0.0 -2.180003 0.0 0.0 -2.182503 0.0 0.0 -2.185003 0.0 0.0 -2.187503 0.0 0.0 -2.190003 0.0 0.0 -2.192503 0.0 0.0 -2.195003 0.0 0.0 -2.197503 0.0 0.0 -2.200003 0.0 0.0 -2.202503 0.0 0.0 -2.205003 0.0 0.0 -2.207503 0.0 0.0 -2.210003 0.0 0.0 -2.212503 0.0 0.0 -2.215003 0.0 0.0 -2.217503 0.0 0.0 -2.220003 0.0 0.0 -2.222503 0.0 0.0 -2.225003 0.0 0.0 -2.227503 0.0 0.0 -2.230003 0.0 0.0 -2.232503 0.0 0.0 -2.235003 0.0 0.0 -2.237503 0.0 0.0 -2.240003 0.0 0.0 -2.242503 0.0 0.0 -2.245003 0.0 0.0 -2.247503 0.0 0.0 -2.250003 0.0 0.0 -2.252503 0.0 0.0 -2.255003 0.0 0.0 -2.257503 0.0 0.0 -2.260003 0.0 0.0 -2.262503 0.0 0.0 -2.265003 0.0 0.0 -2.267503 0.0 0.0 -2.270003 0.0 0.0 -2.272503 0.0 0.0 -2.275003 0.0 0.0 -2.277503 0.0 0.0 -2.280003 0.0 0.0 -2.282503 0.0 0.0 -2.285003 0.0 0.0 -2.287503 0.0 0.0 -2.290003 0.0 0.0 -2.292503 0.0 0.0 -2.295003 0.0 0.0 -2.297503 0.0 0.0 -2.300003 0.0 0.0 -2.302503 0.0 0.0 -2.305003 0.0 0.0 -2.307503 0.0 0.0 -2.310003 0.0 0.0 -2.312503 0.0 0.0 -2.315003 0.0 0.0 -2.317503 0.0 0.0 -2.320003 0.0 0.0 -2.322503 0.0 0.0 -2.325003 0.0 0.0 -2.327503 0.0 0.0 -2.330003 0.0 0.0 -2.332503 0.0 0.0 -2.335003 0.0 0.0 -2.337503 0.0 0.0 -2.340003 0.0 0.0 -2.342503 0.0 0.0 -2.345003 0.0 0.0 -2.347503 0.0 0.0 -2.350003 0.0 0.0 -2.352503 0.0 0.0 -2.355003 0.0 0.0 -2.357503 0.0 0.0 -2.360003 0.0 0.0 -2.362503 0.0 0.0 -2.365003 0.0 0.0 -2.367503 0.0 0.0 -2.370003 0.0 0.0 -2.372503 90.0617291646 0.0 -2.375003 184.195029137 0.0 -2.377503 217.704250195 0.0 -2.380003 503.844683304 0.0 -2.382503 978.712343342 0.0 -2.385003 1902.87115284 0.0 -2.387503 1995.7001685 0.0 -2.390003 2267.15742849 0.0 -2.392503 2316.40088385 0.0 -2.395003 2152.24201557 0.0 -2.397503 1906.12647523 0.0 -2.400003 1619.47365066 0.0 -2.402503 1333.55377251 0.0 -2.405003 1093.76952475 0.0 -2.407503 891.74740735 0.0 -2.410003 748.365046684 0.0 -2.412503 636.865179922 0.0 -2.415003 550.379375698 0.0 -2.417503 492.005597957 0.0 -2.420003 455.449212663 0.0 -2.422503 433.361634297 0.0 -2.425003 427.084589631 0.0 -2.427503 433.425106927 0.0 -2.430003 450.952257779 0.0 -2.432503 479.22119889 0.0 -2.435003 511.448205723 1.50125466728 -2.437503 548.805475295 0.0 -2.440003 584.092440904 0.0 -2.442503 622.791087398 0.0 -2.445003 655.177624449 0.0 -2.447503 685.283415276 0.0 -2.450003 707.1663635 0.0 -2.452503 721.357511371 0.0 -2.455003 729.662392603 0.0 -2.457503 728.273647727 0.0 -2.460003 723.538529445 0.0 -2.462503 710.34260375 0.0 -2.465003 693.748615009 0.0 -2.467503 675.074151096 1.44254725619 -2.470003 654.818057322 0.0 -2.472503 635.550507633 0.0 -2.475003 617.511527387 0.0 -2.477503 599.674943319 0.0 -2.480003 581.31447067 0.0 -2.482503 565.829225092 0.0 -2.485003 552.894827331 0.0 -2.487503 541.738972471 0.0 -2.490003 532.059827741 0.0 -2.492503 526.081191783 0.0 -2.495003 521.588790648 0.72150434195 -2.497503 518.932240317 0.72032106295 -2.500003 521.102766874 0.726485150969 -2.502503 523.8371948 0.0 -2.505003 529.876284902 0.0 -2.507503 536.912845354 1.23106154854 -2.510003 546.512987734 1.22194957556 -2.512503 555.600139914 1.21387268181 -2.515003 567.804284665 0.0 -2.517503 579.546285527 0.0 -2.520003 592.120955525 0.0 -2.522503 603.60877448 0.0 -2.525003 615.215171484 0.0 -2.527503 626.602762823 51.7784177867 -2.530003 636.503666564 0.0 -2.532503 645.63961623 0.0 -2.535003 653.926066016 0.0 -2.537503 660.381211351 0.0 -2.540003 666.311541827 0.0 -2.542503 672.672534345 0.0 -2.545003 675.413363404 0.0 -2.547503 677.600023404 0.0 -2.550003 679.60396483 0.0 -2.552503 681.772768234 0.0 -2.555003 682.673849234 0.0 -2.557503 682.030563029 0.0 -2.560003 682.999687864 0.0 -2.562503 682.215042596 0.0 -2.565003 681.719974097 0.0 -2.567503 681.914366071 0.0 -2.570003 682.583906813 0.0 -2.572503 682.76985622 0.0 -2.575003 683.769393626 0.0 -2.577503 684.96519292 0.0 -2.580003 686.884486522 0.0 -2.582503 689.163318766 0.0 -2.585003 692.266892353 0.0 -2.587503 695.34493593 0.0 -2.590003 700.005110301 0.0 -2.592503 703.727861825 0.0 -2.595003 710.105296174 0.0 -2.597503 714.840268718 0.0 -2.600003 721.909927182 0.0 -2.602503 728.657890614 0.0 -2.605003 737.229276265 0.0 -2.607503 742.066506145 0.0 -2.610003 752.076446529 0.0 -2.612503 758.626987872 0.0 -2.615003 765.984601002 0.0 -2.617503 771.885449997 0.0 -2.620003 779.263801266 0.0 -2.622503 787.813808934 0.0 -2.625003 796.196129186 0.0 -2.627503 802.139105963 0.0 -2.630003 806.949212489 0.0 -2.632503 812.339286451 0.0 -2.635003 818.948353173 0.0 -2.637503 820.913737988 0.0 -2.640003 828.763068116 0.0 -2.642503 835.303063478 0.0 -2.645003 837.730582173 0.0 -2.647503 836.701502486 0.0 -2.650003 844.832693308 0.0 -2.652503 845.607745625 0.0 -2.655003 846.696234903 0.0 -2.657503 847.711514386 0.0 -2.660003 849.578823749 0.0 -2.662503 848.226709649 0.0 -2.665003 846.356224551 0.0 -2.667503 843.631613459 0.0 -2.670003 839.961459728 0.0 -2.672503 835.110920449 0.0 -2.675003 832.030429569 0.0 -2.677503 825.756810756 0.0 -2.680003 821.812361025 0.0 -2.682503 817.802153079 0.0 -2.685003 812.756524379 0.0 -2.687503 810.410858054 0.0 -2.690003 807.642789786 0.0 -2.692503 803.2562013 0.0 -2.695003 805.600481601 0.0 -2.697503 801.695984399 0.101225909415 -2.700003 801.39196659 0.0719775418763 -2.702503 798.470459896 0.0424958867771 -2.705003 796.794103217 0.00238479588158 -2.707503 791.277378706 -0.0313048464624 -2.710003 785.078603178 -0.0465282544268 -2.712503 782.820800789 0.0 -2.715003 772.34280136 0.0 -2.717503 768.047345555 0.0 -2.720003 759.713054521 0.0 -2.722503 744.694189381 0.0 -2.725003 733.219447446 0.0 -2.727503 722.234671076 0.0 -2.730003 706.980259675 0.0 -2.732503 694.246119382 0.0 -2.735003 683.751855509 0.0 -2.737503 677.05402517 0.0 -2.740003 668.712904217 0.0 -2.742503 667.148976497 0.0 -2.745003 661.646845048 0.0 -2.747503 659.220029959 0.0 -2.750003 658.282252323 0.0 -2.752503 660.144768585 0.0 -2.755003 654.807571195 0.0 -2.757503 641.177881555 0.0 -2.760003 624.030549611 0.0 -2.762503 622.877404789 0.0 -2.765003 610.259140473 0.0 -2.767503 595.974424478 0.0 -2.770003 576.665860877 0.0 -2.772503 558.951460675 0.0 -2.775003 545.771099486 0.0 -2.777503 537.958389779 0.0 -2.780003 522.452835284 0.0 -2.782503 525.348887299 0.0 -2.785003 498.696912127 0.0 -2.787503 482.507084162 0.0 -2.790003 473.937809842 0.0 -2.792503 467.039810473 0.0 -2.795003 465.924983047 0.0 -2.797503 458.643070835 0.0 -2.800003 453.217830517 0.0 -2.802503 447.820857695 0.0 -2.805003 463.156606085 0.0 -2.807503 455.615370523 0.0 -2.810003 459.389869003 0.0 -2.812503 464.744283722 0.0 -2.815003 465.093029617 0.0 -2.817503 464.737237134 0.0 -2.820003 462.857782922 0.0 -2.822503 467.467133063 0.0 -2.825003 475.05085811 0.0 -2.827503 478.084284826 0.0 -2.830003 476.604824749 0.0 -2.832503 479.907022624 0.0 -2.835003 471.644464788 0.0 -2.837503 472.106629143 0.0 -2.840003 474.214457892 0.0 -2.842503 468.93135478 0.0 -2.845003 469.609346063 0.0 -2.847503 463.858422901 0.0 -2.850003 454.336076217 0.0 -2.852503 449.879478203 0.0 -2.855003 445.91054896 0.0 -2.857503 445.685729989 0.0 -2.860003 452.373745367 0.0 -2.862503 468.466008102 0.0 -2.865003 450.876870648 0.0 -2.867503 451.31777915 0.0 -2.870003 452.164623146 0.0 -2.872503 454.245380705 0.0 -2.875003 453.903826193 0.0 -2.877503 452.599286978 0.0 -2.880003 451.808659435 0.0 -2.882503 451.67664487 0.0 -2.885003 450.407558096 0.0 -2.887503 449.768041519 0.0 -2.890003 446.835558038 0.0 -2.892503 443.505806331 0.0 -2.895003 441.468347381 0.0 -2.897503 438.306091147 0.0 -2.900003 435.778885929 0.0 -2.902503 433.845408651 0.0 -2.905003 430.105370862 0.0 -2.907503 426.449887796 0.0 -2.910003 423.014963871 0.0 -2.912503 419.434593911 0.0 -2.915003 415.562363824 0.0 -2.917503 413.456092342 0.0 -2.920003 408.395984372 0.0 -2.922503 404.778784813 0.0 -2.925003 401.257098382 0.0 -2.927503 398.263193988 0.0 -2.930003 394.316000474 0.0 -2.932503 391.576537429 0.0 -2.935003 387.673038348 0.0 -2.937503 384.043558898 0.0 -2.940003 381.260888127 0.0 -2.942503 379.200940753 0.0 -2.945003 375.010716741 0.0 -2.947503 372.470102501 0.0 -2.950003 368.308858463 0.0 -2.952503 366.99601428 0.0 -2.955003 364.897013342 0.0 -2.957503 362.79542097 0.0 -2.960003 360.911046581 0.0 -2.962503 359.236652607 0.0 -2.965003 356.375593377 0.0 -2.967503 354.907349875 0.0 -2.970003 352.819877011 0.0 -2.972503 352.283077355 0.0 -2.975003 350.91319282 0.0 -2.977503 350.387622074 0.0 -2.980003 349.827272834 0.0 -2.982503 349.076306501 0.0 -2.985003 347.804424181 0.0 -2.987503 346.880521628 0.0 -2.990003 345.766400772 0.0 -2.992503 344.773093587 0.0 -2.995003 343.490310715 0.0 -2.997503 342.071773397 0.0 -3.000003 340.894725005 0.0 -3.002503 339.014684543 0.0 -3.005003 337.451018834 0.0 -3.007503 335.893490225 0.0 -3.010003 334.347947314 0.0 -3.012503 332.205510916 0.0 -3.015003 330.754535694 0.0 -3.017503 327.989416906 0.0 -3.020003 325.530098913 0.0 -3.022503 323.046135189 0.0 -3.025003 320.260997029 0.0 -3.027503 317.238657509 0.0 -3.030003 313.942241241 0.0 -3.032503 310.636936262 0.0 -3.035003 305.266011392 0.0 -3.037503 304.9911496 0.0 -3.040003 299.478497025 0.0 -3.042503 298.680639999 0.0 -3.045003 294.803778766 0.0 -3.047503 290.756136434 0.0 -3.050003 287.511536282 0.0 -3.052503 283.662431891 0.0 -3.055003 280.18878325 0.0 -3.057503 276.085495465 0.0 -3.060003 271.426522651 0.0 -3.062503 267.358595007 0.0 -3.065003 263.1839345 0.0 -3.067503 259.507539514 0.0 -3.070003 255.8003863 0.0 -3.072503 252.181923552 0.0 -3.075003 248.352901304 0.0 -3.077503 244.190031704 0.0 -3.080003 239.7531134 0.0 -3.082503 235.510204441 0.0 -3.085003 231.443426798 0.0 -3.087503 227.273721284 0.0 -3.090003 223.132160952 0.0 -3.092503 219.382147061 0.0 -3.095003 213.748515521 0.0 -3.097503 208.907655207 0.0 -3.100003 204.294642074 0.0 -3.102503 198.948980752 0.0 -3.105003 193.034331902 0.0 -3.107503 187.384760876 0.0 -3.110003 182.862356483 0.0 -3.112503 178.558802061 0.0 -3.115003 174.059669898 0.0 -3.117503 169.425816077 0.0 -3.120003 164.9084338 0.0 -3.122503 161.129798607 0.0 -3.125003 156.726654817 0.0 -3.127503 152.540663864 0.0 -3.130003 148.137980288 0.0 -3.132503 144.108113663 0.0 -3.135003 140.258247787 0.0 -3.137503 136.551461775 0.0 -3.140003 133.166180197 0.0 -3.142503 128.573540559 0.0 -3.145003 124.479918393 0.0 -3.147503 120.536157597 0.0 -3.150003 114.668734403 0.0 -3.152503 109.10726526 0.0 -3.155003 104.186795623 0.0 -3.157503 99.6800457117 0.0 -3.160003 98.3556023539 0.0 -3.162503 95.1425380234 0.0 -3.165003 90.9906229727 0.0 -3.167503 85.5070299357 0.0 -3.170003 79.3739604799 0.0 -3.172503 73.3187286767 0.0 -3.175003 67.4753257194 0.0 -3.177503 61.1086687058 0.0 -3.180003 54.8941718252 0.0 -3.182503 48.8314254995 0.0 -3.185003 43.7851252761 0.0 -3.187503 39.1131941587 0.0 -3.190003 34.2415111398 0.0 -3.192503 30.1311595662 0.0 -3.195003 27.2392967866 0.0 -3.197503 25.139296717 0.0 -3.200003 22.2965631241 0.0 -3.202503 21.3330573701 0.0 -3.205003 13.244684806 0.0 -3.207503 11.0183103318 0.0 -3.210003 9.75644695272 0.0 -3.212503 6.35547844825 0.0 -3.215003 3.99225878674 0.0 -3.217503 2.2197901402 0.0 -3.220003 0.233945853237 0.0 -3.222503 -1.28067694475 0.0 -3.225003 -4.15764022553 0.0 -3.227503 -4.39097447357 0.0 -3.230003 -3.36106481781 0.0 -3.232503 -5.33886375422 0.0 -3.235003 -6.64564839695 0.0 -3.237503 -8.11553726872 0.0 -3.240003 -9.28681578542 0.0 -3.242503 -9.28681578542 0.0 -3.245003 -12.7897950759 0.0 -3.247503 -15.4143788479 0.0 -3.250003 -20.0693539242 0.0 -3.252503 -24.3276137973 0.0 -3.255003 -27.8983590078 0.0 -3.257503 0.0 0.0 -3.260003 0.0 0.0 -3.262503 0.0 0.0 -3.265003 0.0 0.0 -3.267503 0.0 0.0 -3.270003 0.0 0.0 -3.272503 0.0 0.0 -3.275003 0.0 0.0 -3.277503 0.0 0.0 -3.280003 0.0 0.0 -3.282503 0.0 0.0 -3.285003 0.0 0.0 -3.287503 0.0 0.0 -3.290003 0.0 0.0 -3.292503 0.0 0.0 -3.295003 0.0 0.0 -3.297503 0.0 0.0 -3.300003 0.0 0.0 -3.302503 0.0 0.0 -3.305003 0.0 0.0 -3.307503 0.0 0.0 -3.310003 0.0 0.0 -3.312503 0.0 0.0 -3.315003 0.0 0.0 -3.317503 0.0 0.0 -3.320003 0.0 0.0 -3.322503 0.0 0.0 -3.325003 0.0 0.0 -3.327503 0.0 0.0 -3.330003 0.0 0.0 -3.332503 0.0 0.0 -3.335003 0.0 0.0 -3.337503 0.0 0.0 -3.340003 0.0 0.0 -3.342503 0.0 0.0 -3.345003 0.0 0.0 -3.347503 0.0 0.0 -3.350003 0.0 0.0 -3.352503 0.0 0.0 -3.355003 0.0 0.0 -3.357503 0.0 0.0 -3.360003 0.0 0.0 -3.362503 0.0 0.0 -3.365003 0.0 0.0 -3.367503 0.0 0.0 -3.370003 0.0 0.0 -3.372503 0.0 0.0 -3.375003 0.0 0.0 -3.377503 0.0 0.0 -3.380003 0.0 0.0 -3.382503 0.0 0.0 -3.385003 0.0 0.0 -3.387503 0.0 0.0 -3.390003 0.0 0.0 -3.392503 0.0 0.0 -3.395003 0.0 0.0 -3.397503 0.0 0.0 -3.400003 0.0 0.0 -3.402503 0.0 0.0 -3.405003 0.0 0.0 -3.407503 0.0 0.0 -3.410003 0.0 0.0 -3.412503 0.0 0.0 -3.415003 0.0 0.0 -3.417503 0.0 0.0 -3.420003 0.0 0.0 -3.422503 0.0 0.0 -3.425003 0.0 0.0 -3.427503 0.0 0.0 -3.430003 0.0 0.0 -3.432503 0.0 0.0 -3.435003 0.0 0.0 -3.437503 0.0 0.0 -3.440003 0.0 0.0 -3.442503 0.0 0.0 -3.445003 0.0 0.0 -3.447503 0.0 0.0 -3.450003 0.0 0.0 -3.452503 0.0 0.0 -3.455003 0.0 0.0 -3.457503 0.0 0.0 -3.460003 0.0 0.0 -3.462503 0.0 0.0 -3.465003 0.0 0.0 -3.467503 0.0 0.0 -3.470003 0.0 0.0 -3.472503 0.0 0.0 -3.475003 0.0 0.0 -3.477503 0.0 0.0 -3.480003 0.0 0.0 -3.482503 0.0 0.0 -3.485003 0.0 0.0 -3.487503 0.0 0.0 -3.490003 0.0 0.0 -3.492503 0.0 0.0 -3.495003 0.0 0.0 -3.497503 0.0 0.0 -3.500003 0.0 0.0 -3.502503 0.0 0.0 -3.505003 0.0 0.0 -3.507503 0.0 0.0 -3.510003 0.0 0.0 -3.512503 0.0 0.0 -3.515003 0.0 0.0 -3.517503 0.0 0.0 -3.520003 0.0 0.0 -3.522503 0.0 0.0 -3.525003 0.0 0.0 -3.527503 0.0 0.0 -3.530003 0.0 0.0 -3.532503 0.0 0.0 -3.535003 0.0 0.0 -3.537503 0.0 0.0 -3.540003 0.0 0.0 -3.542503 0.0 0.0 -3.545003 0.0 0.0 -3.547503 0.0 0.0 -3.550003 0.0 0.0 -3.552503 0.0 0.0 -3.555003 0.0 0.0 -3.557503 0.0 0.0 -3.560003 0.0 0.0 -3.562503 0.0 0.0 -3.565003 0.0 0.0 -3.567503 0.0 0.0 -3.570003 0.0 0.0 -3.572503 0.0 0.0 -3.575003 0.0 0.0 -3.577503 0.0 0.0 -3.580003 0.0 0.0 -3.582503 0.0 0.0 -3.585003 0.0 0.0 -3.587503 0.0 0.0 -3.590003 0.0 0.0 -3.592503 0.0 0.0 -3.595003 0.0 0.0 -3.597503 0.0 0.0 -3.600003 0.0 0.0 -3.602503 0.0 0.0 -3.605003 0.0 0.0 -3.607503 0.0 0.0 -3.610003 0.0 0.0 -3.612503 0.0 0.0 -3.615003 0.0 0.0 -3.617503 0.0 0.0 -3.620003 0.0 0.0 -3.622503 0.0 0.0 -3.625003 0.0 0.0 -3.627503 0.0 0.0 -3.630003 0.0 0.0 -3.632503 0.0 0.0 -3.635003 0.0 0.0 -3.637503 0.0 0.0 -3.640003 0.0 0.0 -3.642503 0.0 0.0 -3.645003 0.0 0.0 -3.647503 0.0 0.0 -3.650003 0.0 0.0 -3.652503 0.0 0.0 -3.655003 0.0 0.0 -3.657503 0.0 0.0 -3.660003 0.0 0.0 -3.662503 0.0 0.0 -3.665003 0.0 0.0 -3.667503 0.0 0.0 -3.670003 0.0 0.0 -3.672503 0.0 0.0 -3.675003 0.0 0.0 -3.677503 0.0 0.0 -3.680003 0.0 0.0 -3.682503 0.0 0.0 -3.685003 0.0 0.0 -3.687503 0.0 0.0 -3.690003 0.0 0.0 -3.692503 0.0 0.0 -3.695003 0.0 0.0 -3.697503 0.0 0.0 -3.700003 0.0 0.0 -3.702503 0.0 0.0 -3.705003 0.0 0.0 -3.707503 0.0 0.0 -3.710003 0.0 0.0 -3.712503 0.0 0.0 -3.715003 0.0 0.0 -3.717503 0.0 0.0 -3.720003 0.0 0.0 -3.722503 0.0 0.0 -3.725003 0.0 0.0 -3.727503 0.0 0.0 -3.730003 0.0 0.0 -3.732503 0.0 0.0 -3.735003 0.0 0.0 -3.737503 0.0 0.0 -3.740003 0.0 0.0 -3.742503 0.0 0.0 -3.745003 0.0 0.0 -3.747503 0.0 0.0 -3.750003 0.0 0.0 -3.752503 0.0 0.0 -3.755003 0.0 0.0 -3.757503 0.0 0.0 -3.760003 0.0 0.0 -3.762503 0.0 0.0 -3.765003 0.0 0.0 -3.767503 0.0 0.0 -3.770003 0.0 0.0 -3.772503 0.0 0.0 -3.775003 0.0 0.0 -3.777503 0.0 0.0 -3.780003 0.0 0.0 -3.782503 0.0 0.0 -3.785003 0.0 0.0 -3.787503 0.0 0.0 -3.790003 0.0 0.0 -3.792503 0.0 0.0 -3.795003 0.0 0.0 -3.797503 0.0 0.0 -3.800003 0.0 0.0 -3.802503 0.0 0.0 -3.805003 0.0 0.0 -3.807503 0.0 0.0 -3.810003 0.0 0.0 -3.812503 0.0 0.0 -3.815003 0.0 0.0 -3.817503 0.0 0.0 -3.820003 0.0 0.0 -3.822503 0.0 0.0 -3.825003 0.0 0.0 -3.827503 0.0 0.0 -3.830003 0.0 0.0 -3.832503 0.0 0.0 -3.835003 0.0 0.0 -3.837503 0.0 0.0 -3.840003 0.0 0.0 -3.842503 0.0 0.0 -3.845003 0.0 0.0 -3.847503 0.0 0.0 -3.850003 0.0 0.0 -3.852503 0.0 0.0 -3.855003 0.0 0.0 -3.857503 0.0 0.0 -3.860003 0.0 0.0 -3.862503 0.0 0.0 -3.865003 0.0 0.0 -3.867503 0.0 0.0 -3.870003 0.0 0.0 -3.872503 0.0 0.0 -3.875003 0.0 0.0 -3.877503 0.0 0.0 -3.880003 0.0 0.0 -3.882503 0.0 0.0 -3.885003 0.0 0.0 -3.887503 0.0 0.0 -3.890003 0.0 0.0 -3.892503 0.0 0.0 -3.895003 0.0 0.0 -3.897503 0.0 0.0 -3.900003 0.0 0.0 -3.902503 0.0 0.0 -3.905003 0.0 0.0 -3.907503 0.0 0.0 -3.910003 0.0 0.0 -3.912503 0.0 0.0 -3.915003 0.0 0.0 -3.917503 0.0 0.0 -3.920003 0.0 0.0 -3.922503 0.0 0.0 -3.925003 0.0 0.0 -3.927503 0.0 0.0 -3.930003 0.0 0.0 -3.932503 0.0 0.0 -3.935003 0.0 0.0 -3.937503 0.0 0.0 -3.940003 0.0 0.0 -3.942503 0.0 0.0 -3.945003 0.0 0.0 -3.947503 0.0 0.0 -3.950003 0.0 0.0 -3.952503 0.0 0.0 -3.955003 0.0 0.0 -3.957503 0.0 0.0 -3.960003 0.0 0.0 -3.962503 0.0 0.0 -3.965003 0.0 0.0 -3.967503 0.0 0.0 -3.970003 0.0 0.0 -3.972503 0.0 0.0 -3.975003 0.0 0.0 -3.977503 0.0 0.0 -3.980003 0.0 0.0 -3.982503 0.0 0.0 -3.985003 0.0 0.0 -3.987503 0.0 0.0 -3.990003 0.0 0.0 -3.992503 0.0 0.0 -3.995003 0.0 0.0 -3.997503 0.0 0.0 -4.000003 0.0 0.0 -4.002503 0.0 0.0 -4.005003 0.0 0.0 -4.007503 0.0 0.0 -4.010003 0.0 0.0 -4.012503 0.0 0.0 -4.015003 0.0 0.0 -4.017503 0.0 0.0 -4.020003 0.0 0.0 -4.022503 0.0 0.0 -4.025003 0.0 0.0 -4.027503 0.0 0.0 -4.030003 0.0 0.0 -4.032503 0.0 0.0 -4.035003 0.0 0.0 -4.037503 0.0 0.0 -4.040003 0.0 0.0 -4.042503 0.0 0.0 -4.045003 0.0 0.0 -4.047503 0.0 0.0 -4.050003 0.0 0.0 -4.052503 0.0 0.0 -4.055003 0.0 0.0 -4.057503 0.0 0.0 -4.060003 0.0 0.0 -4.062503 0.0 0.0 -4.065003 0.0 0.0 -4.067503 0.0 0.0 -4.070003 0.0 0.0 -4.072503 0.0 0.0 -4.075003 0.0 0.0 -4.077503 0.0 0.0 -4.080003 0.0 0.0 -4.082503 0.0 0.0 -4.085003 0.0 0.0 -4.087503 0.0 0.0 -4.090003 0.0 0.0 -4.092503 0.0 0.0 -4.095003 0.0 0.0 -4.097503 0.0 0.0 -4.100003 0.0 0.0 -4.102503 0.0 0.0 -4.105003 0.0 0.0 -4.107503 0.0 0.0 -4.110003 0.0 0.0 -4.112503 0.0 0.0 -4.115003 0.0 0.0 -4.117503 0.0 0.0 -4.120003 0.0 0.0 -4.122503 0.0 0.0 -4.125003 0.0 0.0 -4.127503 0.0 0.0 -4.130003 0.0 0.0 -4.132503 0.0 0.0 -4.135003 0.0 0.0 -4.137503 0.0 0.0 -4.140003 0.0 0.0 -4.142503 0.0 0.0 -4.145003 0.0 0.0 -4.147503 0.0 0.0 -4.150003 0.0 0.0 -4.152503 0.0 0.0 -4.155003 0.0 0.0 -4.157503 0.0 0.0 -4.160003 0.0 0.0 -4.162503 0.0 0.0 -4.165003 0.0 0.0 -4.167503 0.0 0.0 -4.170003 0.0 0.0 -4.172503 0.0 0.0 -4.175003 0.0 0.0 -4.177503 0.0 0.0 -4.180003 0.0 0.0 -4.182503 0.0 0.0 -4.185003 0.0 0.0 -4.187503 0.0 0.0 -4.190003 0.0 0.0 -4.192503 0.0 0.0 -4.195003 0.0 0.0 -4.197503 0.0 0.0 -4.200003 0.0 0.0 -4.202503 0.0 0.0 -4.205003 0.0 0.0 -4.207503 0.0 0.0 -4.210003 0.0 0.0 -4.212503 0.0 0.0 -4.215003 0.0 0.0 -4.217503 0.0 0.0 -4.220003 0.0 0.0 -4.222503 0.0 0.0 -4.225003 0.0 0.0 -4.227503 0.0 0.0 -4.230003 0.0 0.0 -4.232503 0.0 0.0 -4.235003 0.0 0.0 -4.237503 0.0 0.0 -4.240003 0.0 0.0 -4.242503 0.0 0.0 -4.245003 0.0 0.0 -4.247503 0.0 0.0 -4.250003 0.0 0.0 -4.252503 0.0 0.0 -4.255003 0.0 0.0 -4.257503 1.12292505867 0.0 -4.260003 620.272585308 0.0 -4.262503 1115.96059066 0.0 -4.265003 1051.39888542 0.0 -4.267503 1192.29872171 0.0 -4.270003 1390.71393024 0.0 -4.272503 1143.67696609 0.0 -4.275003 812.8423857 0.0 -4.277503 1193.52022552 0.0 -4.280003 1971.58379082 0.0 -4.282503 2643.04894716 0.0 -4.285003 2643.04894716 0.0 -4.287503 -382.945887621 0.0 -4.290003 209.006759704 0.0 -4.292503 209.006759704 0.0 -4.295003 -625.569037122 0.0 -4.297503 -80.6014322359 0.0 -4.300003 179.797430914 0.0 -4.302503 205.992360231 0.0 -4.305003 255.097471624 0.0 -4.307503 389.811829324 0.0 -4.310003 381.353835969 0.0 -4.312503 313.582245165 0.0 -4.315003 350.663955731 0.0 -4.317503 364.809093453 0.0 -4.320003 355.63465373 0.0 -4.322503 254.596393189 0.0 -4.325003 177.46289307 0.0 -4.327503 158.801315431 0.0 -4.330003 65.2796508229 0.0 -4.332503 77.0456690069 0.0 -4.335003 18.6128490933 0.0 -4.337503 53.6587087893 0.0 -4.340003 85.3975008643 0.0 -4.342503 91.8270212211 0.0 -4.345003 13.440753082 0.0 -4.347503 43.7474003996 0.0 -4.350003 54.9163450282 0.0 -4.352503 -3.06585992159 0.0 -4.355003 6.52010009254 0.0 -4.357503 57.3724752627 0.0 -4.360003 51.8562589075 0.0 -4.362503 147.646739463 0.0 -4.365003 163.61164321 0.0 -4.367503 151.794020318 0.0 -4.370003 107.248132047 0.0 -4.372503 109.767776002 0.0 -4.375003 162.40381332 0.0 -4.377503 180.016835153 0.0 -4.380003 195.662652583 0.0 -4.382503 224.418362806 0.0 -4.385003 237.611880648 0.0 -4.387503 260.937008764 0.0 -4.390003 301.430286066 0.0 -4.392503 441.182435762 0.0 -4.395003 493.6038051 0.0 -4.397503 450.658119665 0.0 -4.400003 422.621123383 0.0 -4.402503 512.468172322 0.0 -4.405003 545.646781348 0.0 -4.407503 480.191287834 0.0 -4.410003 506.20800269 0.0 -4.412503 499.415787548 0.0 -4.415003 522.404504971 0.0 -4.417503 520.078823408 0.0 -4.420003 536.149054424 0.0 -4.422503 540.585927083 0.0 -4.425003 543.87210666 0.0 -4.427503 533.34630856 0.0 -4.430003 538.75817538 0.0 -4.432503 554.526772641 0.0 -4.435003 542.383128825 0.0 -4.437503 546.27301177 0.0 -4.440003 549.44116194 0.0 -4.442503 533.452540933 0.0 -4.445003 530.837050233 0.0 -4.447503 522.386932345 0.0 -4.450003 513.456500324 0.0 -4.452503 502.608855296 0.0 -4.455003 494.964562235 0.0 -4.457503 490.011655656 0.0 -4.460003 482.712476732 0.0 -4.462503 475.301603692 0.0 -4.465003 468.459302122 0.0 -4.467503 474.433041719 0.0 -4.470003 473.097049759 0.0 -4.472503 476.972704667 0.0 -4.475003 483.190118939 0.0 -4.477503 487.191762016 0.0 -4.480003 500.743046017 0.0 -4.482503 498.767591439 0.0 -4.485003 514.839780041 0.0 -4.487503 529.345470893 0.0 -4.490003 530.108029818 0.0 -4.492503 529.84478179 0.0 -4.495003 548.153185485 0.0 -4.497503 545.585976764 0.0 -4.500003 559.880138651 0.0 -4.502503 565.891638636 0.0 -4.505003 564.649392956 0.0 -4.507503 573.164179341 0.0 -4.510003 583.987740206 0.0 -4.512503 589.63759775 0.0 -4.515003 594.284259429 0.0 -4.517503 599.110222246 0.0 -4.520003 610.772236323 0.0 -4.522503 597.358300788 0.0 -4.525003 604.61257032 0.0 -4.527503 600.695401365 0.0 -4.530003 595.31988002 0.0 -4.532503 595.010963297 0.0 -4.535003 597.110842102 0.0 -4.537503 598.152334522 0.0 -4.540003 606.945777156 0.0 -4.542503 600.817817544 0.0 -4.545003 601.497703041 0.0 -4.547503 610.696744631 0.0 -4.550003 618.118319267 0.0 -4.552503 613.797396973 0.0 -4.555003 617.107208392 0.0 -4.557503 610.528379009 0.0 -4.560003 613.180961469 0.0 -4.562503 608.377614432 0.0 -4.565003 608.007067003 0.0 -4.567503 600.14598877 0.0 -4.570003 604.449278387 0.0 -4.572503 597.799991088 0.0 -4.575003 588.380538518 0.0 -4.577503 583.428112208 0.0 -4.580003 586.827927495 0.0 -4.582503 588.614159933 0.0 -4.585003 580.448105806 0.0 -4.587503 587.716676253 0.0 -4.590003 585.04036561 0.0 -4.592503 587.906902357 0.0 -4.595003 595.686551827 0.0 -4.597503 594.184561195 0.0 -4.600003 596.341507817 0.0 -4.602503 605.162762781 0.0 -4.605003 601.082220547 0.0 -4.607503 598.52102737 0.0 -4.610003 601.509262751 0.0 -4.612503 607.440612348 0.0 -4.615003 607.655020523 0.0 -4.617503 606.599810384 0.0 -4.620003 607.559646692 0.0 -4.622503 607.612888726 0.0 -4.625003 605.661748472 0.0 -4.627503 598.378517174 0.0 -4.630003 597.719877542 0.0 -4.632503 594.715600915 0.0 -4.635003 597.810765624 0.0 -4.637503 591.191123303 0.0 -4.640003 592.80985757 0.0 -4.642503 587.387686096 0.0 -4.645003 591.535502551 0.0 -4.647503 588.12928265 0.0 -4.650003 590.697666569 0.0 -4.652503 591.671488486 0.0 -4.655003 593.504708232 0.0 -4.657503 592.481772111 0.0 -4.660003 592.972166711 0.0 -4.662503 597.733214961 0.0 -4.665003 595.208790368 0.0 -4.667503 596.037570588 0.0 -4.670003 592.037988895 0.0 -4.672503 582.716455203 0.0 -4.675003 579.701537018 0.0 -4.677503 574.270164245 0.0 -4.680003 571.566512757 0.0 -4.682503 570.768993131 0.0 -4.685003 565.355181515 0.0 -4.687503 566.212727354 0.0 -4.690003 565.795421404 0.0 -4.692503 559.482227392 0.0 -4.695003 554.241277547 0.0 -4.697503 554.358407104 0.0 -4.700003 552.973349919 0.0 -4.702503 566.511021902 0.0 -4.705003 572.037826152 0.0 -4.707503 575.774474596 0.0 -4.710003 582.894628231 0.0 -4.712503 585.534465805 0.0 -4.715003 588.661501693 0.0 -4.717503 588.117034948 0.0 -4.720003 588.146931581 0.0 -4.722503 586.360780376 0.0 -4.725003 583.148001769 0.0 -4.727503 579.149101469 0.0 -4.730003 574.326472776 0.0 -4.732503 568.092321021 0.0 -4.735003 561.350975601 0.0 -4.737503 553.615592607 0.0 -4.740003 546.634726485 0.0 -4.742503 541.032621481 0.0 -4.745003 534.432877245 0.0 -4.747503 527.645928993 0.0 -4.750003 525.266201103 0.0 -4.752503 522.100323172 0.0 -4.755003 516.383051467 0.0 -4.757503 514.656181309 0.0 -4.760003 514.600369767 0.0 -4.762503 513.748652411 0.0 -4.765003 513.570183701 0.0 -4.767503 515.464973858 0.0 -4.770003 515.144650182 0.0 -4.772503 516.802711529 0.0 -4.775003 518.658680017 0.0 -4.777503 518.58724576 0.0 -4.780003 524.318380381 0.0 -4.782503 523.264798128 0.0 -4.785003 527.036452852 0.0 -4.787503 528.508494053 0.0 -4.790003 531.726451887 0.0 -4.792503 535.155156022 0.0 -4.795003 533.930159022 0.0 -4.797503 537.178839679 0.0 -4.800003 538.488853149 0.0 -4.802503 538.904106371 0.0 -4.805003 538.206101596 0.0 -4.807503 538.266000827 0.0 -4.810003 538.668701877 0.0 -4.812503 539.75864125 0.0 -4.815003 534.776720793 0.0 -4.817503 535.098593374 0.0 -4.820003 535.095799448 0.0 -4.822503 533.021523223 0.0 -4.825003 529.820736519 0.0 -4.827503 528.523955314 0.0 -4.830003 526.818444552 0.0 -4.832503 525.049341165 0.0 -4.835003 521.59805039 0.0 -4.837503 517.276106687 0.0 -4.840003 515.055855086 0.0 -4.842503 510.944556624 0.0 -4.845003 508.084111445 0.0 -4.847503 505.455564875 0.0 -4.850003 502.330278954 0.0 -4.852503 498.938464326 0.0 -4.855003 497.71223576 0.0 -4.857503 495.716687379 0.0 -4.860003 493.463318065 0.0 -4.862503 492.424977398 0.0 -4.865003 491.394868523 0.0 -4.867503 489.628441863 0.0 -4.870003 489.624865796 0.0 -4.872503 489.280169509 0.0 -4.875003 488.821628358 0.0 -4.877503 488.370919519 0.0 -4.880003 485.638996376 0.0 -4.882503 483.894976638 0.0 -4.885003 483.910511092 0.0 -4.887503 481.361303765 0.0 -4.890003 478.911348529 0.0 -4.892503 475.210084759 0.0 -4.895003 473.633232096 0.0 -4.897503 471.967589348 0.0 -4.900003 468.826572776 0.0 -4.902503 468.508670074 0.0 -4.905003 461.653008662 0.0 -4.907503 460.370749399 0.0 -4.910003 458.895779798 0.0 -4.912503 455.65753332 0.0 -4.915003 453.876479613 0.0 -4.917503 449.021420598 0.0 -4.920003 448.029352246 0.0 -4.922503 443.767071163 0.0 -4.925003 441.152984744 0.0 -4.927503 435.918658725 0.0 -4.930003 436.999395301 0.0 -4.932503 433.13066131 0.0 -4.935003 429.367765571 0.0 -4.937503 431.08608444 0.0 -4.940003 425.931922179 0.0 -4.942503 424.122227711 0.0 -4.945003 422.684589584 0.0 -4.947503 419.538999879 0.0 -4.950003 415.317772697 0.0 -4.952503 413.396240645 0.0 -4.955003 414.033188797 0.0 -4.957503 408.065625893 0.0 -4.960003 404.794451204 0.0 -4.962503 402.394706073 0.0 -4.965003 398.182573698 0.0 -4.967503 394.908188916 0.0 -4.970003 391.135508688 0.0 -4.972503 388.175096198 0.0 -4.975003 386.284106142 0.0 -4.977503 381.302887763 0.0 -4.980003 378.244651122 0.0 -4.982503 375.443653314 0.0 -4.985003 371.025142054 0.0 -4.987503 367.806806198 0.0 -4.990003 365.42782552 0.0 -4.992503 361.94067858 0.0 -4.995003 360.725171255 0.0 -4.997503 358.04751859 0.0 -5.000003 358.803153341 0.0 -5.002503 358.935042981 0.0 -5.005003 354.845186341 0.0 -5.007503 353.530068132 0.0 -5.010003 352.082137465 0.0 -5.012503 348.905076323 0.0 -5.015003 341.605035152 0.0 -5.017503 340.453541273 0.0 -5.020003 334.409148111 0.0 -5.022503 333.304069047 0.0 -5.025003 328.915905873 0.0 -5.027503 325.655517315 0.0 -5.030003 319.581394519 0.0 -5.032503 314.514820724 0.0 -5.035003 310.411756523 0.0 -5.037503 307.791094775 0.0 -5.040003 300.64255456 0.0 -5.042503 305.136786314 0.0 -5.045003 294.733926008 0.0 -5.047503 295.373251966 0.0 -5.050003 277.021433426 0.0 -5.052503 278.055296579 0.0 -5.055003 277.068586629 0.0 -5.057503 273.788282855 0.0 -5.060003 264.082377584 0.0 -5.062503 256.667319946 0.0 -5.065003 253.568041888 0.0 -5.067503 252.836440281 0.0 -5.070003 241.911866318 0.0 -5.072503 241.678792071 0.0 -5.075003 228.026156265 0.0 -5.077503 228.556381528 0.0 -5.080003 218.127358579 0.0 -5.082503 213.37011078 0.0 -5.085003 210.321619601 0.0 -5.087503 192.886918942 0.0 -5.090003 199.892834996 0.0 -5.092503 188.528858536 0.0 -5.095003 189.392213663 0.0 -5.097503 181.93618753 0.0 -5.100003 178.204197362 0.0 -5.102503 167.90595449 0.0 -5.105003 160.20500876 0.0 -5.107503 157.752445109 0.0 -5.110003 146.032218661 0.0 -5.112503 140.50056516 0.0 -5.115003 132.569022126 0.0 -5.117503 124.546379401 0.0 -5.120003 119.513797827 0.0 -5.122503 109.052381055 0.0 -5.125003 109.93292844 0.0 -5.127503 102.045675501 0.0 -5.130003 100.339343759 0.0 -5.132503 85.3404199158 0.0 -5.135003 86.1016617471 0.0 -5.137503 81.253754291 0.0 -5.140003 83.2027412442 0.0 -5.142503 81.1612282807 0.0 -5.145003 77.1476254581 0.0 -5.147503 70.7730701505 0.0 -5.150003 67.6780245928 0.0 -5.152503 57.7585766785 0.0 -5.155003 55.3896069572 0.0 -5.157503 49.7396470386 0.0 -5.160003 53.7426515886 0.0 -5.162503 42.1785419181 0.0 -5.165003 36.5399039634 0.0 -5.167503 32.994489081 0.0 -5.170003 29.8701748758 0.0 -5.172503 24.1446381481 0.0 -5.175003 24.5578336867 0.0 -5.177503 20.3548126923 0.0 -5.180003 11.2168195596 0.0 -5.182503 2.67769381207 0.0 -5.185003 1.7710741327 0.0 -5.187503 -2.50704847878 0.0 -5.190003 -7.28535805977 0.0 -5.192503 -13.6740349026 0.0 -5.195003 -20.4559935997 0.0 -5.197503 0.0 0.0 -5.200003 0.0 0.0 -5.202503 0.0 0.0 -5.205003 0.0 0.0 -5.207503 0.0 0.0 -5.210003 0.0 0.0 -5.212503 0.0 0.0 -5.215003 0.0 0.0 -5.217503 0.0 0.0 -5.220003 0.0 0.0 -5.222503 0.0 0.0 -5.225003 0.0 0.0 -5.227503 0.0 0.0 -5.230003 0.0 0.0 -5.232503 0.0 0.0 -5.235003 0.0 0.0 -5.237503 0.0 0.0 -5.240003 0.0 0.0 -5.242503 0.0 0.0 -5.245003 0.0 0.0 -5.247503 0.0 0.0 -5.250003 0.0 0.0 -5.252503 0.0 0.0 -5.255003 0.0 0.0 -5.257503 0.0 0.0 -5.260003 0.0 0.0 -5.262503 0.0 0.0 -5.265003 0.0 0.0 -5.267503 0.0 0.0 -5.270003 0.0 0.0 -5.272503 0.0 0.0 -5.275003 0.0 0.0 -5.277503 0.0 0.0 -5.280003 0.0 0.0 -5.282503 0.0 0.0 -5.285003 0.0 0.0 -5.287503 0.0 0.0 -5.290003 0.0 0.0 -5.292503 0.0 0.0 -5.295003 0.0 0.0 -5.297503 0.0 0.0 -5.300003 0.0 0.0 -5.302503 0.0 0.0 -5.305003 0.0 0.0 -5.307503 0.0 0.0 -5.310003 0.0 0.0 -5.312503 0.0 0.0 -5.315003 0.0 0.0 -5.317503 0.0 0.0 -5.320003 0.0 0.0 -5.322503 0.0 0.0 -5.325003 0.0 0.0 -5.327503 0.0 0.0 -5.330003 0.0 0.0 -5.332503 0.0 0.0 -5.335003 0.0 0.0 -5.337503 0.0 0.0 -5.340003 0.0 0.0 -5.342503 0.0 0.0 -5.345003 0.0 0.0 -5.347503 0.0 0.0 -5.350003 0.0 0.0 -5.352503 0.0 0.0 -5.355003 0.0 0.0 -5.357503 0.0 0.0 -5.360003 0.0 0.0 -5.362503 0.0 0.0 -5.365003 0.0 0.0 -5.367503 0.0 0.0 -5.370003 0.0 0.0 -5.372503 0.0 0.0 -5.375003 0.0 0.0 -5.377503 0.0 0.0 -5.380003 0.0 0.0 -5.382503 0.0 0.0 -5.385003 0.0 0.0 -5.387503 0.0 0.0 -5.390003 0.0 0.0 -5.392503 0.0 0.0 -5.395003 0.0 0.0 -5.397503 0.0 0.0 -5.400003 0.0 0.0 -5.402503 0.0 0.0 -5.405003 0.0 0.0 -5.407503 0.0 0.0 -5.410003 0.0 0.0 -5.412503 0.0 0.0 -5.415003 0.0 0.0 -5.417503 0.0 0.0 -5.420003 0.0 0.0 -5.422503 0.0 0.0 -5.425003 0.0 0.0 -5.427503 0.0 0.0 -5.430003 0.0 0.0 -5.432503 0.0 0.0 -5.435003 0.0 0.0 -5.437503 0.0 0.0 -5.440003 0.0 0.0 -5.442503 0.0 0.0 -5.445003 0.0 0.0 -5.447503 0.0 0.0 -5.450003 0.0 0.0 -5.452503 0.0 0.0 -5.455003 0.0 0.0 -5.457503 0.0 0.0 -5.460003 0.0 0.0 -5.462503 0.0 0.0 -5.465003 0.0 0.0 -5.467503 0.0 0.0 -5.470003 0.0 0.0 -5.472503 0.0 0.0 -5.475003 0.0 0.0 -5.477503 0.0 0.0 -5.480003 0.0 0.0 -5.482503 0.0 0.0 -5.485003 0.0 0.0 -5.487503 0.0 0.0 -5.490003 0.0 0.0 -5.492503 0.0 0.0 -5.495003 0.0 0.0 -5.497503 0.0 0.0 -5.500003 0.0 0.0 -5.502503 0.0 0.0 -5.505003 0.0 0.0 -5.507503 0.0 0.0 -5.510003 0.0 0.0 -5.512503 0.0 0.0 -5.515003 0.0 0.0 -5.517503 0.0 0.0 -5.520003 0.0 0.0 -5.522503 0.0 0.0 -5.525003 0.0 0.0 -5.527503 0.0 0.0 -5.530003 0.0 0.0 -5.532503 0.0 0.0 -5.535003 0.0 0.0 -5.537503 0.0 0.0 -5.540003 0.0 0.0 -5.542503 0.0 0.0 -5.545003 0.0 0.0 -5.547503 0.0 0.0 -5.550003 0.0 0.0 -5.552503 0.0 0.0 -5.555003 0.0 0.0 -5.557503 0.0 0.0 -5.560003 0.0 0.0 -5.562503 0.0 0.0 -5.565003 0.0 0.0 -5.567503 0.0 0.0 -5.570003 0.0 0.0 -5.572503 0.0 0.0 -5.575003 0.0 0.0 -5.577503 0.0 0.0 -5.580003 0.0 0.0 -5.582503 0.0 0.0 -5.585003 0.0 0.0 -5.587503 0.0 0.0 -5.590003 0.0 0.0 -5.592503 0.0 0.0 -5.595003 0.0 0.0 -5.597503 0.0 0.0 -5.600003 0.0 0.0 -5.602503 0.0 0.0 -5.605003 0.0 0.0 -5.607503 0.0 0.0 -5.610003 0.0 0.0 -5.612503 0.0 0.0 -5.615003 0.0 0.0 -5.617503 0.0 0.0 -5.620003 0.0 0.0 -5.622503 0.0 0.0 -5.625003 0.0 0.0 -5.627503 0.0 0.0 -5.630003 0.0 0.0 -5.632503 0.0 0.0 -5.635003 0.0 0.0 -5.637503 0.0 0.0 -5.640003 0.0 0.0 -5.642503 0.0 0.0 -5.645003 0.0 0.0 -5.647503 0.0 0.0 -5.650003 0.0 0.0 -5.652503 0.0 0.0 -5.655003 0.0 0.0 -5.657503 0.0 0.0 -5.660003 0.0 0.0 -5.662503 0.0 0.0 -5.665003 0.0 0.0 -5.667503 0.0 0.0 -5.670003 0.0 0.0 -5.672503 0.0 0.0 -5.675003 0.0 0.0 -5.677503 0.0 0.0 -5.680003 0.0 0.0 -5.682503 0.0 0.0 -5.685003 0.0 0.0 -5.687503 0.0 0.0 -5.690003 0.0 0.0 -5.692503 0.0 0.0 -5.695003 0.0 0.0 -5.697503 0.0 0.0 -5.700003 0.0 0.0 -5.702503 0.0 0.0 -5.705003 0.0 0.0 -5.707503 0.0 0.0 -5.710003 0.0 0.0 -5.712503 0.0 0.0 -5.715003 0.0 0.0 -5.717503 0.0 0.0 -5.720003 0.0 0.0 -5.722503 0.0 0.0 -5.725003 0.0 0.0 -5.727503 0.0 0.0 -5.730003 0.0 0.0 -5.732503 0.0 0.0 -5.735003 0.0 0.0 -5.737503 0.0 0.0 -5.740003 0.0 0.0 -5.742503 0.0 0.0 -5.745003 0.0 0.0 -5.747503 0.0 0.0 -5.750003 0.0 0.0 -5.752503 0.0 0.0 -5.755003 0.0 0.0 -5.757503 0.0 0.0 -5.760003 0.0 0.0 -5.762503 0.0 0.0 -5.765003 0.0 0.0 -5.767503 0.0 0.0 -5.770003 0.0 0.0 -5.772503 0.0 0.0 -5.775003 0.0 0.0 -5.777503 0.0 0.0 -5.780003 0.0 0.0 -5.782503 0.0 0.0 -5.785003 0.0 0.0 -5.787503 0.0 0.0 -5.790003 0.0 0.0 -5.792503 0.0 0.0 -5.795003 0.0 0.0 -5.797503 0.0 0.0 -5.800003 0.0 0.0 -5.802503 0.0 0.0 -5.805003 0.0 0.0 -5.807503 0.0 0.0 -5.810003 0.0 0.0 -5.812503 0.0 0.0 -5.815003 0.0 0.0 -5.817503 0.0 0.0 -5.820003 0.0 0.0 -5.822503 0.0 0.0 -5.825003 0.0 0.0 -5.827503 0.0 0.0 -5.830003 0.0 0.0 -5.832503 0.0 0.0 -5.835003 0.0 0.0 -5.837503 0.0 0.0 -5.840003 0.0 0.0 -5.842503 0.0 0.0 -5.845003 0.0 0.0 -5.847503 0.0 0.0 -5.850003 0.0 0.0 -5.852503 0.0 0.0 -5.855003 0.0 0.0 -5.857503 0.0 0.0 -5.860003 0.0 0.0 -5.862503 0.0 0.0 -5.865003 0.0 0.0 -5.867503 0.0 0.0 -5.870003 0.0 0.0 -5.872503 0.0 0.0 -5.875003 0.0 0.0 -5.877503 0.0 0.0 -5.880003 0.0 0.0 -5.882503 0.0 0.0 -5.885003 0.0 0.0 -5.887503 0.0 0.0 -5.890003 0.0 0.0 -5.892503 0.0 0.0 -5.895003 0.0 0.0 -5.897503 0.0 0.0 -5.900003 0.0 0.0 -5.902503 0.0 0.0 -5.905003 0.0 0.0 -5.907503 0.0 0.0 -5.910003 0.0 0.0 -5.912503 0.0 0.0 -5.915003 0.0 0.0 -5.917503 0.0 0.0 -5.920003 0.0 0.0 -5.922503 0.0 0.0 -5.925003 0.0 0.0 -5.927503 0.0 0.0 -5.930003 0.0 0.0 -5.932503 0.0 0.0 -5.935003 0.0 0.0 -5.937503 0.0 0.0 -5.940003 0.0 0.0 -5.942503 0.0 0.0 -5.945003 0.0 0.0 -5.947503 0.0 0.0 -5.950003 0.0 0.0 -5.952503 0.0 0.0 -5.955003 0.0 0.0 -5.957503 0.0 0.0 -5.960003 0.0 0.0 -5.962503 0.0 0.0 -5.965003 0.0 0.0 -5.967503 0.0 0.0 -5.970003 0.0 0.0 -5.972503 0.0 0.0 -5.975003 0.0 0.0 -5.977503 0.0 0.0 -5.980003 0.0 0.0 -5.982503 0.0 0.0 -5.985003 0.0 0.0 -5.987503 0.0 0.0 -5.990003 0.0 0.0 -5.992503 0.0 0.0 -5.995003 0.0 0.0 -5.997503 0.0 0.0 -6.000003 0.0 0.0 -6.002503 0.0 0.0 -6.005003 0.0 0.0 -6.007503 0.0 0.0 -6.010003 0.0 0.0 -6.012503 0.0 0.0 -6.015003 0.0 0.0 -6.017503 0.0 0.0 -6.020003 0.0 0.0 -6.022503 0.0 0.0 -6.025003 0.0 0.0 -6.027503 0.0 0.0 -6.030003 0.0 0.0 -6.032503 0.0 0.0 -6.035003 0.0 0.0 -6.037503 0.0 0.0 -6.040003 0.0 0.0 -6.042503 0.0 0.0 -6.045003 0.0 0.0 -6.047503 0.0 0.0 -6.050003 0.0 0.0 -6.052503 0.0 0.0 -6.055003 0.0 0.0 -6.057503 0.0 0.0 -6.060003 0.0 0.0 -6.062503 0.0 0.0 -6.065003 0.0 0.0 -6.067503 0.0 0.0 -6.070003 0.0 0.0 -6.072503 0.0 0.0 -6.075003 0.0 0.0 -6.077503 0.0 0.0 -6.080003 0.0 0.0 -6.082503 0.0 0.0 -6.085003 0.0 0.0 -6.087503 0.0 0.0 -6.090003 0.0 0.0 -6.092503 0.0 0.0 -6.095003 0.0 0.0 -6.097503 0.0 0.0 -6.100003 0.0 0.0 -6.102503 0.0 0.0 -6.105003 0.0 0.0 -6.107503 0.0 0.0 -6.110003 0.0 0.0 -6.112503 0.0 0.0 -6.115003 0.0 0.0 -6.117503 0.0 0.0 -6.120003 0.0 0.0 -6.122503 0.0 0.0 -6.125003 0.0 0.0 -6.127503 0.0 0.0 -6.130003 0.0 0.0 -6.132503 0.0 0.0 -6.135003 0.0 0.0 -6.137503 0.0 0.0 -6.140003 0.0 0.0 -6.142503 0.0 0.0 -6.145003 0.0 0.0 -6.147503 0.0 0.0 -6.150003 0.0 0.0 -6.152503 0.0 0.0 -6.155003 0.0 0.0 -6.157503 0.0 0.0 -6.160003 0.0 0.0 -6.162503 0.0 0.0 -6.165003 0.0 0.0 -6.167503 0.0 0.0 -6.170003 0.0 0.0 -6.172503 0.0 0.0 -6.175003 0.0 0.0 -6.177503 0.0 0.0 -6.180003 0.0 0.0 -6.182503 0.0 0.0 -6.185003 0.0 0.0 -6.187503 0.0 0.0 -6.190003 0.0 0.0 -6.192503 0.0 0.0 -6.195003 0.0 0.0 -6.197503 0.0 0.0 -6.200003 0.0 0.0 -6.202503 0.0 0.0 -6.205003 0.0 0.0 -6.207503 0.0 0.0 -6.210003 0.0 0.0 -6.212503 0.0 0.0 -6.215003 0.0 0.0 -6.217503 0.0 0.0 -6.220003 600.14419488 0.0 -6.222503 862.990343456 0.0 -6.225003 1214.05467211 0.0 -6.227503 1546.29997132 0.0 -6.230003 1516.47378417 0.0 -6.232503 1353.75626152 0.0 -6.235003 1261.75934267 0.0 -6.237503 1122.15140106 0.0 -6.240003 996.990317399 0.0 -6.242503 993.718713551 0.0 -6.245003 1047.28862646 0.0 -6.247503 1199.60902081 0.0 -6.250003 1630.40797742 0.0 -6.252503 2328.04971317 0.0 -6.255003 2824.32413854 0.0 -6.257503 3191.28114059 0.0 -6.260003 3052.11177449 0.0 -6.262503 2629.90762574 0.0 -6.265003 2079.38595094 0.0 -6.267503 1559.9208213 0.0 -6.270003 1079.44916674 0.0 -6.272503 669.557537739 0.0 -6.275003 381.312652361 0.0 -6.277503 197.719464825 0.0 -6.280003 98.6309694053 0.0 -6.282503 71.1954143354 0.0 -6.285003 84.4364462046 0.0 -6.287503 161.21803152 0.0 -6.290003 252.943214643 0.0 -6.292503 349.279606873 0.0 -6.295003 449.451661043 0.0 -6.297503 562.94381367 0.0 -6.300003 562.94381367 0.0 -6.302503 672.004939029 0.0 -6.305003 751.967646128 0.0 -6.307503 812.579597679 0.0 -6.310003 858.563615096 0.0 -6.312503 878.290499192 0.0 -6.315003 872.397778451 0.0 -6.317503 842.849709373 0.0 -6.320003 799.268594546 0.0 -6.322503 749.923513885 0.0 -6.325003 703.5813668 0.0 -6.327503 652.021755826 0.0 -6.330003 604.180453921 0.0 -6.332503 570.570564782 0.0 -6.335003 533.564850812 0.0 -6.337503 508.934230712 0.0 -6.340003 497.652959291 0.0 -6.342503 496.629427517 0.0 -6.345003 494.154633349 0.0 -6.347503 499.564969153 0.0 -6.350003 510.470825633 0.0 -6.352503 523.819526017 -0.024420193219 -6.355003 540.579985882 12.1143661629 -6.357503 551.405065483 0.0 -6.360003 571.305627051 0.0 -6.362503 583.888245971 0.0 -6.365003 590.99675944 0.0 -6.367503 603.18977745 0.0 -6.370003 608.699937454 0.0 -6.372503 618.698589572 0.0 -6.375003 626.289980828 0.0 -6.377503 628.779773415 0.0 -6.380003 631.459365247 0.0 -6.382503 635.107781597 0.0 -6.385003 638.075153522 0.0 -6.387503 637.902846498 0.0 -6.390003 640.195227248 0.0 -6.392503 639.894454403 0.0 -6.395003 639.824046252 0.0 -6.397503 637.614318318 0.0 -6.400003 638.554603855 -7.76795712428 -6.402503 647.055292279 -8.93216661343 -6.405003 649.695490725 -3.95600534221 -6.407503 650.859591372 -5.57131512377 -6.410003 653.948126132 -2.76621860004 -6.412503 656.060305698 -3.64856465358 -6.415003 652.309454331 -3.60172990411 -6.417503 654.165506482 -4.04448138989 -6.420003 655.762887643 -2.97606427289 -6.422503 652.778307932 -2.588643599 -6.425003 654.682784965 0.392432943055 -6.427503 653.196719993 0.931585827224 -6.430003 656.392059463 0.153373766559 -6.432503 657.076163789 -0.586113675118 -6.435003 662.363602807 -0.355867789294 -6.437503 671.193533775 0.822646086704 -6.440003 672.692602798 1.32561661194 -6.442503 681.330586748 0.656661084063 -6.445003 677.490566109 1.05574024111 -6.447503 682.949201913 0.215703624587 -6.450003 686.743430995 -0.912717396605 -6.452503 691.989706032 4.48525612622 -6.455003 686.94234708 0.980674687301 -6.457503 685.783905451 1.71594703839 -6.460003 679.694195197 2.92812161531 -6.462503 681.487416462 2.01058169323 -6.465003 681.818807664 4.55339811373 -6.467503 680.483927269 5.22612953859 -6.470003 682.811950024 5.05102487734 -6.472503 690.195221411 2.39754745791 -6.475003 687.719927776 2.41314139443 -6.477503 687.924731869 2.18609050704 -6.480003 694.863038148 1.00614464988 -6.482503 686.852720118 -0.396285391196 -6.485003 697.664543524 -1.22397060182 -6.487503 701.554419175 -0.486497685761 -6.490003 704.540906574 -0.415883933651 -6.492503 704.617029244 1.06727036767 -6.495003 716.213184514 0.0 -6.497503 720.479559434 0.0 -6.500003 728.087087074 0.0 -6.502503 732.615541568 0.0 -6.505003 741.095881126 0.0 -6.507503 753.536968311 0.0 -6.510003 755.982949125 0.0 -6.512503 760.329619271 0.0 -6.515003 768.488373596 0.0 -6.517503 773.139931617 0.0 -6.520003 776.202619505 0.0 -6.522503 786.303346456 3.96687365241 -6.525003 790.115363164 3.04609793098 -6.527503 796.728397763 -6.61164775298 -6.530003 804.807834301 32.4009202369 -6.532503 811.265005179 -6.62846830961 -6.535003 814.395788857 6.77592793854 -6.537503 817.122844282 1.74329038192 -6.540003 819.480401159 -1.29387158884 -6.542503 813.338428343 0.0 -6.545003 812.609220825 0.0 -6.547503 812.946061746 0.0 -6.550003 824.336003252 0.0 -6.552503 821.124142381 0.0 -6.555003 828.383451396 0.0 -6.557503 834.678981801 0.0 -6.560003 836.267616054 0.0 -6.562503 829.825468732 0.0 -6.565003 824.318419599 0.0 -6.567503 820.174160626 0.0 -6.570003 845.00329032 0.0 -6.572503 845.087978189 0.0 -6.575003 844.195428572 0.0 -6.577503 840.879840967 0.0 -6.580003 838.459590328 0.0 -6.582503 839.126276877 0.0 -6.585003 838.82773567 0.0 -6.587503 843.308758829 0.0 -6.590003 845.237579149 0.0 -6.592503 838.0399107 0.0 -6.595003 844.512111914 0.0 -6.597503 831.57284739 0.0 -6.600003 831.273809618 -0.51551841975 -6.602503 838.499106353 -0.563009607273 -6.605003 832.56099599 0.0 -6.607503 822.500755839 0.0 -6.610003 824.678814084 0.0 -6.612503 822.081106764 0.0 -6.615003 815.364504966 0.0 -6.617503 810.174917836 0.0 -6.620003 799.363875888 0.0 -6.622503 803.618963587 0.0 -6.625003 794.408851889 0.0 -6.627503 784.505775851 0.0 -6.630003 794.248395076 0.0 -6.632503 767.041173038 0.0 -6.635003 745.283469912 0.0 -6.637503 743.607711943 0.0 -6.640003 733.983416088 0.0 -6.642503 728.26187913 0.0 -6.645003 724.739759995 0.0 -6.647503 708.468324198 0.0 -6.650003 699.944272603 0.0 -6.652503 681.433812622 0.0 -6.655003 688.87995079 0.0 -6.657503 671.701185033 0.0 -6.660003 643.835919761 0.0 -6.662503 613.13100989 0.0 -6.665003 588.287993223 0.0 -6.667503 590.808430899 0.0 -6.670003 553.194524903 0.0 -6.672503 521.610379562 0.0 -6.675003 489.076787398 0.0 -6.677503 453.063785934 0.0 -6.680003 426.685916435 0.0 -6.682503 388.161460349 0.0 -6.685003 331.82380769 0.0 -6.687503 269.766860062 0.0 -6.690003 219.76732925 0.0 -6.692503 215.42950301 0.0 -6.695003 160.563214746 0.0 -6.697503 150.384190128 0.0 -6.700003 147.522325448 0.0 -6.702503 125.129270468 0.0 -6.705003 183.962607306 0.0 -6.707503 198.542536513 0.0 -6.710003 180.533959485 0.0 -6.712503 180.533959485 0.0 -6.715003 285.86015432 0.0 -6.717503 271.239468112 0.0 -6.720003 230.015175721 0.0 -6.722503 256.422582576 0.0 -6.725003 271.651760061 0.0 -6.727503 241.562899801 0.0 -6.730003 189.905123228 0.0 -6.732503 225.357366857 0.0 -6.735003 238.363404546 0.0 -6.737503 252.561403906 0.0 -6.740003 299.947010804 0.0 -6.742503 358.24267604 0.0 -6.745003 338.44139437 0.0 -6.747503 365.366673557 0.0 -6.750003 428.498028454 0.0 -6.752503 419.616282703 0.0 -6.755003 430.591675558 0.0 -6.757503 446.970859444 0.0 -6.760003 433.910141231 0.0 -6.762503 407.145861966 0.0 -6.765003 392.526474592 0.0 -6.767503 405.93378141 0.0 -6.770003 396.269393726 0.0 -6.772503 351.658131976 0.0 -6.775003 419.320072691 0.0 -6.777503 418.224588477 0.0 -6.780003 384.43473789 0.0 -6.782503 365.828130265 0.0 -6.785003 421.369583221 0.0 -6.787503 411.769923668 0.0 -6.790003 390.018496365 0.0 -6.792503 378.17721668 0.0 -6.795003 351.477240835 0.0 -6.797503 336.007323056 0.0 -6.800003 329.23913069 0.0 -6.802503 324.317892153 0.0 -6.805003 303.136118483 0.0 -6.807503 291.625732395 0.0 -6.810003 282.670295189 0.0 -6.812503 272.263297295 0.0 -6.815003 273.946577751 0.0 -6.817503 262.049495804 0.0 -6.820003 254.820183811 0.0 -6.822503 251.359222441 0.0 -6.825003 258.565602331 0.0 -6.827503 251.59712242 0.0 -6.830003 252.367996398 0.0 -6.832503 254.270901702 0.0 -6.835003 261.813879982 0.0 -6.837503 268.897960769 0.0 -6.840003 266.006857716 0.0 -6.842503 270.64416726 0.0 -6.845003 276.068046754 0.0 -6.847503 267.809422545 0.0 -6.850003 251.626396881 0.0 -6.852503 250.935553477 0.0 -6.855003 244.881668258 0.0 -6.857503 230.752013306 0.0 -6.860003 227.837785347 0.0 -6.862503 215.802423197 0.0 -6.865003 205.393216341 0.0 -6.867503 192.472367233 0.0 -6.870003 182.11065402 0.0 -6.872503 175.581213888 0.0 -6.875003 174.043083386 0.0 -6.877503 171.478652414 0.0 -6.880003 175.873828284 0.0 -6.882503 177.358056547 0.0 -6.885003 176.618858553 0.0 -6.887503 171.419496178 0.0 -6.890003 187.199080837 0.0 -6.892503 188.931124303 0.0 -6.895003 191.730057107 0.0 -6.897503 192.867604647 0.0 -6.900003 202.71977514 0.0 -6.902503 214.795073039 0.0 -6.905003 215.989104153 0.0 -6.907503 216.095993397 0.0 -6.910003 239.789539613 0.0 -6.912503 223.112060965 0.0 -6.915003 223.807948603 0.0 -6.917503 227.634657116 0.0 -6.920003 219.399474323 0.0 -6.922503 222.995621107 0.0 -6.925003 213.826832712 0.0 -6.927503 205.299371552 0.0 -6.930003 223.330689162 0.0 -6.932503 206.830088285 0.0 -6.935003 194.741220433 0.0 -6.937503 190.791136359 0.0 -6.940003 201.365591841 0.0 -6.942503 181.940767608 0.0 -6.945003 185.918519355 0.0 -6.947503 180.445399901 0.0 -6.950003 172.202889485 0.0 -6.952503 170.947713769 0.0 -6.955003 171.986557758 0.0 -6.957503 169.213441193 0.0 -6.960003 162.255682556 0.0 -6.962503 161.176333271 0.0 -6.965003 164.934693914 0.0 -6.967503 170.709161823 0.0 -6.970003 166.015074817 0.0 -6.972503 158.216139837 0.0 -6.975003 157.826552296 0.0 -6.977503 155.141561536 0.0 -6.980003 154.923071231 0.0 -6.982503 150.31787415 0.0 -6.985003 140.458679221 0.0 -6.987503 143.96555914 0.0 -6.990003 135.827176201 0.0 -6.992503 134.792512362 0.0 -6.995003 127.988528425 0.0 -6.997503 126.815030525 0.0 -7.000003 118.396991751 0.0 -7.002503 117.553621539 0.0 -7.005003 113.818627474 0.0 -7.007503 112.666308896 0.0 -7.010003 101.881153793 0.0 -7.012503 95.9615055239 0.0 -7.015003 95.8075870044 0.0 -7.017503 89.7661216768 0.0 -7.020003 83.3549352587 0.0 -7.022503 79.9722870564 0.0 -7.025003 75.8103183864 0.0 -7.027503 72.5862042978 0.0 -7.030003 64.7255250788 0.0 -7.032503 60.794809048 0.0 -7.035003 52.3679211109 0.0 -7.037503 51.330132182 0.0 -7.040003 51.9624422918 0.0 -7.042503 46.4525990667 0.0 -7.045003 35.2334274725 0.0 -7.047503 28.2195593594 0.0 -7.050003 23.4463585754 0.0 -7.052503 18.9519367522 0.0 -7.055003 13.9013773057 0.0 -7.057503 10.6137605761 0.0 -7.060003 7.36412967552 0.0 -7.062503 1.88425678813 0.0 -7.065003 -2.23437310916 0.0 -7.067503 -5.32817632506 0.0 -7.070003 -6.24493348724 0.0 -7.072503 -7.8240501381 0.0 -7.075003 -12.1048324228 0.0 -7.077503 -16.2405053142 0.0 -7.080003 -18.1652138524 0.0 -7.082503 -22.3611606233 0.0 -7.085003 0.0 0.0 -7.087503 0.0 0.0 -7.090003 0.0 0.0 -7.092503 0.0 0.0 -7.095003 0.0 0.0 -7.097503 0.0 0.0 -7.100003 0.0 0.0 -7.102503 0.0 0.0 -7.105003 0.0 0.0 -7.107503 0.0 0.0 -7.110003 0.0 0.0 -7.112503 0.0 0.0 -7.115003 0.0 0.0 -7.117503 0.0 0.0 -7.120003 0.0 0.0 -7.122503 0.0 0.0 -7.125003 0.0 0.0 -7.127503 0.0 0.0 -7.130003 0.0 0.0 -7.132503 0.0 0.0 -7.135003 0.0 0.0 -7.137503 0.0 0.0 -7.140003 0.0 0.0 -7.142503 0.0 0.0 -7.145003 0.0 0.0 -7.147503 0.0 0.0 -7.150003 0.0 0.0 -7.152503 0.0 0.0 -7.155003 0.0 0.0 -7.157503 0.0 0.0 -7.160003 0.0 0.0 -7.162503 0.0 0.0 -7.165003 0.0 0.0 -7.167503 0.0 0.0 -7.170003 0.0 0.0 -7.172503 0.0 0.0 -7.175003 0.0 0.0 -7.177503 0.0 0.0 -7.180003 0.0 0.0 -7.182503 0.0 0.0 -7.185003 0.0 0.0 -7.187503 0.0 0.0 -7.190003 0.0 0.0 -7.192503 0.0 0.0 -7.195003 0.0 0.0 -7.197503 0.0 0.0 -7.200003 0.0 0.0 -7.202503 0.0 0.0 -7.205003 0.0 0.0 -7.207503 0.0 0.0 -7.210003 0.0 0.0 -7.212503 0.0 0.0 -7.215003 0.0 0.0 -7.217503 0.0 0.0 -7.220003 0.0 0.0 -7.222503 0.0 0.0 -7.225003 0.0 0.0 -7.227503 0.0 0.0 -7.230003 0.0 0.0 -7.232503 0.0 0.0 -7.235003 0.0 0.0 -7.237503 0.0 0.0 -7.240003 0.0 0.0 -7.242503 0.0 0.0 -7.245003 0.0 0.0 -7.247503 0.0 0.0 -7.250003 0.0 0.0 -7.252503 0.0 0.0 -7.255003 0.0 0.0 -7.257503 0.0 0.0 -7.260003 0.0 0.0 -7.262503 0.0 0.0 -7.265003 0.0 0.0 -7.267503 0.0 0.0 -7.270003 0.0 0.0 -7.272503 0.0 0.0 -7.275003 0.0 0.0 -7.277503 0.0 0.0 -7.280003 0.0 0.0 -7.282503 0.0 0.0 -7.285003 0.0 0.0 -7.287503 0.0 0.0 -7.290003 0.0 0.0 -7.292503 0.0 0.0 -7.295003 0.0 0.0 -7.297503 0.0 0.0 -7.300003 0.0 0.0 -7.302503 0.0 0.0 -7.305003 0.0 0.0 -7.307503 0.0 0.0 -7.310003 0.0 0.0 -7.312503 0.0 0.0 -7.315003 0.0 0.0 -7.317503 0.0 0.0 -7.320003 0.0 0.0 -7.322503 0.0 0.0 -7.325003 0.0 0.0 -7.327503 0.0 0.0 -7.330003 0.0 0.0 -7.332503 0.0 0.0 -7.335003 0.0 0.0 -7.337503 0.0 0.0 -7.340003 0.0 0.0 -7.342503 0.0 0.0 -7.345003 0.0 0.0 -7.347503 0.0 0.0 -7.350003 0.0 0.0 -7.352503 0.0 0.0 -7.355003 0.0 0.0 -7.357503 0.0 0.0 -7.360003 0.0 0.0 -7.362503 0.0 0.0 -7.365003 0.0 0.0 -7.367503 0.0 0.0 -7.370003 0.0 0.0 -7.372503 0.0 0.0 -7.375003 0.0 0.0 -7.377503 0.0 0.0 -7.380003 0.0 0.0 -7.382503 0.0 0.0 -7.385003 0.0 0.0 -7.387503 0.0 0.0 -7.390003 0.0 0.0 -7.392503 0.0 0.0 -7.395003 0.0 0.0 -7.397503 0.0 0.0 -7.400003 0.0 0.0 -7.402503 0.0 0.0 -7.405003 0.0 0.0 -7.407503 0.0 0.0 -7.410003 0.0 0.0 -7.412503 0.0 0.0 -7.415003 0.0 0.0 -7.417503 0.0 0.0 -7.420003 0.0 0.0 -7.422503 0.0 0.0 -7.425003 0.0 0.0 -7.427503 0.0 0.0 -7.430003 0.0 0.0 -7.432503 0.0 0.0 -7.435003 0.0 0.0 -7.437503 0.0 0.0 -7.440003 0.0 0.0 -7.442503 0.0 0.0 -7.445003 0.0 0.0 -7.447503 0.0 0.0 -7.450003 0.0 0.0 -7.452503 0.0 0.0 -7.455003 0.0 0.0 -7.457503 0.0 0.0 -7.460003 0.0 0.0 -7.462503 0.0 0.0 -7.465003 0.0 0.0 -7.467503 0.0 0.0 -7.470003 0.0 0.0 -7.472503 0.0 0.0 -7.475003 0.0 0.0 -7.477503 0.0 0.0 -7.480003 0.0 0.0 -7.482503 0.0 0.0 -7.485003 0.0 0.0 -7.487503 0.0 0.0 -7.490003 0.0 0.0 -7.492503 0.0 0.0 -7.495003 0.0 0.0 -7.497503 0.0 0.0 -7.500003 0.0 0.0 -7.502503 0.0 0.0 -7.505003 0.0 0.0 -7.507503 0.0 0.0 -7.510003 0.0 0.0 -7.512503 0.0 0.0 -7.515003 0.0 0.0 -7.517503 0.0 0.0 -7.520003 0.0 0.0 -7.522503 0.0 0.0 -7.525003 0.0 0.0 -7.527503 0.0 0.0 -7.530003 0.0 0.0 -7.532503 0.0 0.0 -7.535003 0.0 0.0 -7.537503 0.0 0.0 -7.540003 0.0 0.0 -7.542503 0.0 0.0 -7.545003 0.0 0.0 -7.547503 0.0 0.0 -7.550003 0.0 0.0 -7.552503 0.0 0.0 -7.555003 0.0 0.0 -7.557503 0.0 0.0 -7.560003 0.0 0.0 -7.562503 0.0 0.0 -7.565003 0.0 0.0 -7.567503 0.0 0.0 -7.570003 0.0 0.0 -7.572503 0.0 0.0 -7.575003 0.0 0.0 -7.577503 0.0 0.0 -7.580003 0.0 0.0 -7.582503 0.0 0.0 -7.585003 0.0 1.13888944478 -7.587503 0.0 0.0 -7.590003 0.0 0.0 -7.592503 0.0 0.0 -7.595003 0.0 0.0 -7.597503 0.0 0.0 -7.600003 0.0 0.0 -7.602503 0.0 0.0 -7.605003 0.0 0.0 -7.607503 0.0 0.0 -7.610003 0.0 0.0 -7.612503 0.0 0.0 -7.615003 0.0 0.0 -7.617503 0.0 0.0 -7.620003 0.0 0.0 -7.622503 0.0 0.0 -7.625003 0.0 0.0 -7.627503 0.0 0.0 -7.630003 0.0 0.0 -7.632503 0.0 0.0 -7.635003 0.0 0.0 -7.637503 0.0 0.0 -7.640003 0.0 0.0 -7.642503 0.0 0.0 -7.645003 0.0 0.0 -7.647503 0.0 0.0 -7.650003 0.0 0.0 -7.652503 0.0 0.0 -7.655003 0.0 0.0 -7.657503 0.0 0.0 -7.660003 0.0 0.0 -7.662503 0.0 0.0 -7.665003 0.0 0.0 -7.667503 0.0 0.0 -7.670003 2.31751722163 0.0 -7.672503 0.0 0.0 -7.675003 0.0 0.0 -7.677503 0.0 0.0 -7.680003 0.0 0.0 -7.682503 0.0 0.0 -7.685003 0.0 0.0 -7.687503 0.0 0.0 -7.690003 0.0 0.0 -7.692503 0.0 0.0 -7.695003 0.0 0.0 -7.697503 0.0 0.0 -7.700003 0.0 0.0 -7.702503 0.0 0.0 -7.705003 0.0 0.0 -7.707503 0.0 0.0 -7.710003 0.0 0.0 -7.712503 0.0 0.0 -7.715003 0.0 0.0 -7.717503 0.0 0.0 -7.720003 0.0 0.0 -7.722503 0.0 0.0 -7.725003 0.0 0.0 -7.727503 0.0 0.0 -7.730003 0.0 0.0 -7.732503 0.0 0.0 -7.735003 0.0 0.0 -7.737503 0.0 0.0 -7.740003 0.0 0.0 -7.742503 0.0 0.0 -7.745003 0.0 0.0 -7.747503 0.0 0.0 -7.750003 0.0 0.0 -7.752503 0.0 0.0 -7.755003 0.0 0.0 -7.757503 0.0 0.0 -7.760003 0.0 0.0 -7.762503 0.0 0.0 -7.765003 0.0 0.0 -7.767503 0.0 0.0 -7.770003 0.0 0.0 -7.772503 0.0 0.0 -7.775003 0.0 0.0 -7.777503 0.0 0.0 -7.780003 0.0 0.0 -7.782503 0.0 0.0 -7.785003 0.0 0.0 -7.787503 0.0 0.0 -7.790003 0.0 0.0 -7.792503 0.0 0.0 -7.795003 0.0 0.0 -7.797503 0.0 0.0 -7.800003 0.0 0.0 -7.802503 0.0 0.0 -7.805003 0.0 0.0 -7.807503 0.0 0.0 -7.810003 0.0 0.0 -7.812503 0.0 0.0 -7.815003 0.0 0.0 -7.817503 0.0 0.0 -7.820003 0.0 0.0 -7.822503 0.0 0.0 -7.825003 0.0 0.0 -7.827503 0.0 0.0 -7.830003 0.0 0.0 -7.832503 0.0 0.0 -7.835003 0.0 0.0 -7.837503 0.0 0.0 -7.840003 0.0 0.0 -7.842503 0.0 0.0 -7.845003 0.0 0.0 -7.847503 0.0 0.0 -7.850003 0.0 0.0 -7.852503 0.0 0.0 -7.855003 0.0 0.0 -7.857503 0.0 0.0 -7.860003 0.0 0.0 -7.862503 0.0 0.0 -7.865003 0.0 0.0 -7.867503 0.0 0.0 -7.870003 0.0 0.0 -7.872503 0.0 0.0 -7.875003 0.0 0.0 -7.877503 0.0 0.0 -7.880003 0.0 0.0 -7.882503 0.0 0.0 -7.885003 0.0 0.0 -7.887503 0.0 0.0 -7.890003 0.0 0.0 -7.892503 0.0 0.0 -7.895003 0.0 0.0 -7.897503 0.0 0.0 -7.900003 0.0 0.0 -7.902503 0.0 0.0 -7.905003 0.0 0.0 -7.907503 0.0 0.0 -7.910003 0.0 0.0 -7.912503 0.0 0.0 -7.915003 0.0 0.0 -7.917503 0.0 0.0 -7.920003 0.0 0.0 -7.922503 0.0 0.0 -7.925003 0.0 0.0 -7.927503 0.0 0.0 -7.930003 0.0 0.0 -7.932503 0.0 0.0 -7.935003 0.0 0.0 -7.937503 0.0 0.0 -7.940003 0.0 0.0 -7.942503 0.0 0.0 -7.945003 0.0 0.0 -7.947503 0.0 0.0 -7.950003 0.0 0.0 -7.952503 0.0 0.0 -7.955003 0.0 0.0 -7.957503 0.0 0.0 -7.960003 0.0 0.0 -7.962503 0.0 0.0 -7.965003 0.0 0.0 -7.967503 0.0 0.0 -7.970003 0.0 0.0 -7.972503 0.0 0.0 -7.975003 0.0 0.0 -7.977503 0.0 0.0 -7.980003 0.0 0.0 -7.982503 0.0 0.0 -7.985003 0.0 0.0 -7.987503 0.0 0.0 -7.990003 0.0 0.0 -7.992503 0.0 0.0 -7.995003 0.0 0.0 -7.997503 0.0 0.0 -8.000003 0.0 0.0 -8.002503 0.0 0.0 -8.005003 0.0 0.0 -8.007503 0.0 0.0 -8.010003 0.0 0.0 -8.012503 0.0 0.0 -8.015003 0.0 0.0 -8.017503 0.0 0.0 -8.020003 0.0 0.0 -8.022503 0.0 0.0 -8.025003 0.0 0.0 -8.027503 0.0 0.0 -8.030003 0.0 0.0 -8.032503 0.0 0.0 -8.035003 0.0 0.0 -8.037503 0.0 0.0 -8.040003 0.0 0.0 -8.042503 0.0 0.0 -8.045003 0.0 0.0 -8.047503 0.0 0.0 -8.050003 0.0 0.0 -8.052503 0.0 0.0 -8.055003 0.0 0.0 -8.057503 0.0 0.0 -8.060003 0.0 0.0 -8.062503 0.0 0.0 -8.065003 0.0 0.0 -8.067503 0.0 0.0 -8.070003 0.0 0.0 -8.072503 0.0 0.0 -8.075003 0.0 0.0 -8.077503 0.0 0.0 -8.080003 43.8106951666 0.0 -8.082503 37.4668482944 0.0 -8.085003 58.84006888 0.0 -8.087503 15.9029457467 0.0 -8.090003 34.2090872886 0.0 -8.092503 93.3600198387 0.0 -8.095003 131.524097621 0.0 -8.097503 278.30455097 0.0 -8.100003 419.120058337 0.0 -8.102503 312.970250875 0.0 -8.105003 679.50856668 0.0 -8.107503 690.268274212 0.0 -8.110003 1138.98173908 0.0 -8.112503 1480.81684404 0.0 -8.115003 1544.23529175 0.0 -8.117503 1447.10754594 0.0 -8.120003 1348.3022657 0.0 -8.122503 1306.25809133 0.0 -8.125003 1249.68986733 0.0 -8.127503 1253.20018837 0.0 -8.130003 1107.24601885 0.0 -8.132503 1079.24409624 0.0 -8.135003 1076.8883259 0.0 -8.137503 1018.98854453 0.0 -8.140003 930.966696939 0.0 -8.142503 875.476161392 0.0 -8.145003 823.261310992 0.0 -8.147503 820.618477243 0.0 -8.150003 800.657901959 0.0 -8.152503 743.858664708 0.0 -8.155003 720.78362542 0.0 -8.157503 713.603337989 0.0 -8.160003 715.024120485 0.0 -8.162503 687.939897042 0.0 -8.165003 648.113737998 0.0 -8.167503 572.673729416 0.0 -8.170003 606.707375551 0.0 -8.172503 639.866338137 0.0 -8.175003 633.472045162 0.0 -8.177503 682.538632078 0.0 -8.180003 745.250362309 0.0 -8.182503 775.987663998 0.0 -8.185003 803.887797527 0.0 -8.187503 797.014166603 0.0 -8.190003 795.024509863 0.0 -8.192503 741.43669005 0.0 -8.195003 550.8566374 0.0 -8.197503 567.99257679 0.0 -8.200003 564.87244575 0.0 -8.202503 539.849233977 0.0 -8.205003 478.293847603 0.0 -8.207503 469.644315078 0.0 -8.210003 491.294284167 0.0 -8.212503 551.320212466 0.0 -8.215003 605.64952436 0.0 -8.217503 642.692846548 0.0 -8.220003 688.638491336 0.0 -8.222503 733.238614324 0.0 -8.225003 737.454582032 0.0 -8.227503 772.256461458 0.0 -8.230003 771.395142679 0.0 -8.232503 775.115235818 0.0 -8.235003 717.037079928 0.0 -8.237503 581.446736941 0.0 -8.240003 467.119783834 0.0 -8.242503 513.854260234 0.0 -8.245003 537.203534657 0.0 -8.247503 510.431213073 0.0 -8.250003 531.168067868 0.0 -8.252503 570.808809499 0.0 -8.255003 588.541649843 0.0 -8.257503 636.650456704 0.0 -8.260003 674.284718079 0.0 -8.262503 719.538124955 0.0 -8.265003 715.325738873 0.0 -8.267503 715.526870072 0.0 -8.270003 702.552426395 0.0 -8.272503 712.21395607 0.0 -8.275003 668.327222162 0.0 -8.277503 615.709427863 0.0 -8.280003 595.985530063 0.0 -8.282503 564.217468563 0.0 -8.285003 562.675667201 0.0 -8.287503 559.354706901 0.0 -8.290003 576.450053104 0.0 -8.292503 579.42682742 0.0 -8.295003 593.69059943 0.0 -8.297503 609.793437677 0.0 -8.300003 597.432013173 0.0 -8.302503 588.659737941 0.0 -8.305003 600.91408271 0.0 -8.307503 612.225551613 0.0 -8.310003 598.519351938 0.0 -8.312503 596.976526115 0.0 -8.315003 581.110796305 0.0 -8.317503 560.575532024 0.0 -8.320003 567.491992155 0.0 -8.322503 570.110956609 0.0 -8.325003 542.286085955 0.0 -8.327503 564.318972063 0.0 -8.330003 590.626879957 0.0 -8.332503 620.964100687 0.0 -8.335003 644.162246581 0.0 -8.337503 649.614275716 0.0 -8.340003 632.188375628 0.0 -8.342503 616.197201291 0.0 -8.345003 567.953566888 0.0 -8.347503 512.266270106 0.0 -8.350003 513.586222661 0.0 -8.352503 511.333209366 0.0 -8.355003 526.173152567 0.0 -8.357503 553.616757151 0.0 -8.360003 552.658824166 0.0 -8.362503 551.317910702 0.0 -8.365003 587.760416316 0.0 -8.367503 600.090845475 0.742178720198 -8.370003 613.911851823 0.0 -8.372503 615.942775775 0.541462624258 -8.375003 660.653650842 0.0 -8.377503 657.716565987 0.0 -8.380003 688.645118483 0.0 -8.382503 708.69359155 0.0 -8.385003 722.127760214 0.0 -8.387503 734.064719304 0.0 -8.390003 736.97112044 -6.25317905544 -8.392503 729.005355036 0.0 -8.395003 752.698339693 0.577331920054 -8.397503 734.096895714 0.658824480651 -8.400003 695.75361191 0.739920092797 -8.402503 648.28261597 0.0 -8.405003 647.299836244 0.0 -8.407503 653.618842396 0.0 -8.410003 657.583674493 0.394226505697 -8.412503 696.669674523 0.365007179182 -8.415003 735.996202288 0.0 -8.417503 680.310716156 0.0 -8.420003 699.796009566 0.0 -8.422503 714.687052773 0.0 -8.425003 732.471604502 0.0 -8.427503 753.051643528 0.0 -8.430003 736.953705335 0.0 -8.432503 724.815983508 0.0 -8.435003 619.768615113 0.0 -8.437503 630.759172726 0.0 -8.440003 647.660570038 0.0 -8.442503 680.795806214 0.0 -8.445003 681.304535584 0.0 -8.447503 701.369551899 0.0 -8.450003 708.788812477 0.0 -8.452503 722.835337969 0.0 -8.455003 722.490963011 0.0 -8.457503 685.628947584 0.0 -8.460003 700.12792302 0.0 -8.462503 755.230728315 0.0 -8.465003 733.364530033 0.0 -8.467503 785.683777585 0.0 -8.470003 807.413533593 0.0 -8.472503 785.770637309 0.0 -8.475003 788.084310497 0.0 -8.477503 800.163786737 0.0 -8.480003 771.300576053 0.0 -8.482503 795.085089827 0.0 -8.485003 770.531307559 0.0 -8.487503 771.936930488 0.0 -8.490003 778.142316883 0.0 -8.492503 688.676249453 0.0 -8.495003 457.246090478 0.0 -8.497503 468.802424275 0.0 -8.500003 413.884303347 0.0 -8.502503 472.341935011 0.0 -8.505003 476.091951125 0.0 -8.507503 502.871508776 0.0 -8.510003 503.255768691 0.0 -8.512503 537.865749013 0.0 -8.515003 586.959147849 0.0 -8.517503 676.66156942 0.0 -8.520003 672.154126609 0.0 -8.522503 653.638184853 0.0 -8.525003 693.784229488 0.0 -8.527503 631.983281062 0.0 -8.530003 559.362940737 0.0 -8.532503 501.922478026 0.0 -8.535003 487.352475035 0.0 -8.537503 491.849911563 0.0 -8.540003 433.327503152 0.0 -8.542503 364.936169973 0.0 -8.545003 334.90759807 0.0 -8.547503 331.774667758 0.0 -8.550003 193.183091928 0.0 -8.552503 193.872493502 0.0 -8.555003 164.736126935 0.0 -8.557503 125.910361477 0.0 -8.560003 12.7370907898 0.0 -8.562503 62.6176095206 0.0 -8.565003 100.851128546 0.0 -8.567503 52.4015066516 0.0 -8.570003 28.231733296 0.0 -8.572503 137.64588915 0.0 -8.575003 155.574299677 0.0 -8.577503 149.947712669 0.0 -8.580003 242.85671637 0.0 -8.582503 201.26874451 0.0 -8.585003 216.282207296 0.0 -8.587503 328.037970062 0.0 -8.590003 378.398762636 0.0 -8.592503 366.611192574 0.0 -8.595003 314.710246981 0.0 -8.597503 264.492434829 0.0 -8.600003 225.582294869 0.0 -8.602503 277.497677113 113.343735103 -8.605003 193.833973792 -45.6344953182 -8.607503 161.104379748 2.95167205195 -8.610003 140.183976176 0.0 -8.612503 121.997993141 0.0 -8.615003 131.460490636 0.0 -8.617503 136.885056398 0.0 -8.620003 140.632508487 0.0 -8.622503 191.431948476 0.0 -8.625003 198.326779351 0.0 -8.627503 283.004414339 0.0 -8.630003 324.708510206 0.0 -8.632503 344.406048355 0.0 -8.635003 378.144236941 0.0 -8.637503 368.952234383 0.0 -8.640003 351.654194216 0.0 -8.642503 386.148016255 0.0 -8.645003 365.257288691 0.0 -8.647503 308.177320447 0.0 -8.650003 322.501579611 0.0 -8.652503 298.989025374 0.0 -8.655003 277.827712976 0.0 -8.657503 270.180633905 0.0 -8.660003 254.667296774 0.0 -8.662503 261.320675377 0.0 -8.665003 258.097533592 0.0 -8.667503 252.908137967 0.0 -8.670003 248.90416784 0.0 -8.672503 251.203492497 0.0 -8.675003 238.534096521 0.0 -8.677503 251.163433116 0.0 -8.680003 231.883999124 0.0 -8.682503 239.611303201 0.0 -8.685003 237.089775972 0.0 -8.687503 249.016784266 0.0 -8.690003 226.199130751 0.0 -8.692503 216.865657274 0.0 -8.695003 186.860151367 0.0 -8.697503 226.880365272 0.0 -8.700003 258.648381453 0.0 -8.702503 262.299294124 0.0 -8.705003 242.416350739 0.0 -8.707503 247.295436456 0.0 -8.710003 236.268205928 0.0 -8.712503 248.586670262 0.0 -8.715003 256.496440695 0.0 -8.717503 264.25084976 0.0 -8.720003 258.473423657 0.0 -8.722503 247.397553329 0.0 -8.725003 258.54556261 0.0 -8.727503 249.208219271 0.0 -8.730003 226.611636194 0.0 -8.732503 208.103444223 0.0 -8.735003 223.536243477 0.0 -8.737503 230.409193723 0.0 -8.740003 233.515370422 0.0 -8.742503 229.20062512 0.0 -8.745003 231.202364838 0.0 -8.747503 248.683482845 0.0 -8.750003 231.045385904 0.0 -8.752503 189.011637012 0.0 -8.755003 37.5002061098 0.0 -8.757503 155.518401974 0.0 -8.760003 132.926159873 0.0 -8.762503 155.46917157 0.0 -8.765003 -1.92772600966 0.0 -8.767503 179.938084198 0.0 -8.770003 180.667366855 0.0 -8.772503 185.061986775 0.0 -8.775003 223.927472066 0.0 -8.777503 225.501821296 0.0 -8.780003 234.445836419 0.0 -8.782503 217.792890675 0.0 -8.785003 208.810507501 0.0 -8.787503 213.692747411 0.0 -8.790003 213.848511533 0.0 -8.792503 225.060685199 0.0 -8.795003 232.594376853 0.0 -8.797503 226.400933581 0.0 -8.800003 224.462092404 0.0 -8.802503 219.025966515 0.0 -8.805003 236.433051411 0.0 -8.807503 226.897606169 0.0 -8.810003 222.667031736 0.0 -8.812503 216.654373127 0.0 -8.815003 222.167361998 0.0 -8.817503 218.663400469 0.0 -8.820003 225.591934426 0.0 -8.822503 216.900487795 0.0 -8.825003 208.438297386 0.0 -8.827503 204.026623484 0.0 -8.830003 201.272833724 0.0 -8.832503 202.244521665 0.0 -8.835003 190.513684769 0.0 -8.837503 190.578536004 0.0 -8.840003 189.005564139 0.0 -8.842503 182.31019438 0.0 -8.845003 175.59390339 0.0 -8.847503 175.385027744 0.0 -8.850003 170.149486563 0.0 -8.852503 162.094695571 0.0 -8.855003 176.160943516 0.0 -8.857503 185.004867073 0.0 -8.860003 169.873201666 0.0 -8.862503 149.250137319 0.0 -8.865003 152.181050643 0.0 -8.867503 153.174437865 0.0 -8.870003 144.007883242 0.0 -8.872503 150.867021038 0.0 -8.875003 149.249319906 0.0 -8.877503 131.118534165 0.0 -8.880003 133.824695679 0.0 -8.882503 135.13241161 0.0 -8.885003 127.538923833 0.0 -8.887503 123.628402884 0.0 -8.890003 131.900961871 0.0 -8.892503 123.293957951 0.0 -8.895003 122.279379105 0.0 -8.897503 122.961059472 0.0 -8.900003 126.421657635 0.0 -8.902503 118.720667596 0.0 -8.905003 116.042394218 0.0 -8.907503 113.7940433 0.0 -8.910003 113.7940433 0.0 -8.912503 86.9018812583 0.0 -8.915003 85.7891246358 0.0 -8.917503 100.002841546 0.0 -8.920003 77.5507402154 0.0 -8.922503 82.434043503 0.0 -8.925003 84.1503825227 0.0 -8.927503 76.1988757694 0.0 -8.930003 59.7172261634 0.0 -8.932503 68.2433364645 0.0 -8.935003 58.4289611584 0.0 -8.937503 55.1454075645 0.0 -8.940003 61.2660850823 0.0 -8.942503 53.642567449 0.0 -8.945003 44.0803179531 0.0 -8.947503 41.5852444936 0.0 -8.950003 36.984953699 0.0 -8.952503 39.1281000946 0.0 -8.955003 45.8569090267 0.0 -8.957503 38.9309134034 0.0 -8.960003 28.5424198212 0.0 -8.962503 22.7929184938 0.0 -8.965003 41.2710500025 0.0 -8.967503 39.1320871012 0.0 -8.970003 31.4258411362 0.0 -8.972503 23.7071499316 0.0 -8.975003 20.0676849455 0.0 -8.977503 28.4467335147 0.0 -8.980003 29.1509231022 0.0 -8.982503 25.121399731 0.0 -8.985003 26.7148703771 0.0 -8.987503 -29.4629764189 0.0 -8.990003 56.9511920663 0.0 -8.992503 56.6608495876 0.0 -8.995003 19.9844016317 0.0 -8.997503 25.6382651261 0.0 -9.000003 9.74391940536 0.0 -9.002503 9.74391940536 0.0 -9.005003 9.26705351969 0.0 -9.007503 9.26705351969 0.0 -9.010003 28.3455901575 0.0 -9.012503 30.4936554486 0.0 -9.015003 44.676044729 0.0 -9.017503 44.676044729 0.0 -9.020003 4.00645815105 0.0 -9.022503 12.7393708242 0.0 -9.025003 10.02030436 0.0 -9.027503 10.02030436 0.0 -9.030003 11.5970289502 0.0 -9.032503 19.4723661753 0.0 -9.035003 20.4915860261 0.0 -9.037503 17.7442843783 0.0 -9.040003 8.39737653896 0.0 -9.042503 8.39737653896 0.0 -9.045003 16.80678501 0.0 -9.047503 28.9132998552 0.0 -9.050003 21.6901524938 0.0 -9.052503 25.9608840855 0.0 -9.055003 14.4786031197 0.0 -9.057503 -11.5660960892 0.0 -9.060003 -3.20012336217 0.0 -9.062503 -0.308489399416 0.0 -9.065003 13.9430644728 0.0 -9.067503 23.0536912883 0.0 -9.070003 5.81440788222 0.0 -9.072503 1.4660606608 0.0 -9.075003 10.3420609196 0.0 -9.077503 15.3162678833 0.0 -9.080003 0.0 0.0 -9.082503 0.0 0.0 -9.085003 0.0 0.0 -9.087503 0.0 0.0 -9.090003 0.0 0.0 -9.092503 0.0 0.0 -9.095003 0.0 0.0 -9.097503 0.0 0.0 -9.100003 0.0 0.0 -9.102503 0.0 0.0 -9.105003 0.0 0.0 -9.107503 0.0 0.0 -9.110003 0.0 0.0 -9.112503 0.0 0.0 -9.115003 0.0 0.0 -9.117503 0.0 0.0 -9.120003 0.0 0.0 -9.122503 0.0 0.0 -9.125003 0.0 0.0 -9.127503 0.0 0.0 -9.130003 0.0 0.0 -9.132503 0.0 0.0 -9.135003 0.0 0.0 -9.137503 0.0 0.0 -9.140003 0.0 0.0 -9.142503 0.0 0.0 -9.145003 0.0 0.0 -9.147503 0.0 0.0 -9.150003 0.0 0.0 -9.152503 0.0 0.0 -9.155003 0.0 0.0 -9.157503 0.0 0.0 -9.160003 0.0 0.0 -9.162503 0.0 0.0 -9.165003 0.0 0.0 -9.167503 0.0 0.0 -9.170003 0.0 0.0 -9.172503 0.0 0.0 -9.175003 0.0 0.0 -9.177503 0.0 0.0 -9.180003 0.0 0.0 -9.182503 0.0 0.0 -9.185003 0.0 0.0 -9.187503 0.0 0.0 -9.190003 0.0 0.0 -9.192503 0.0 0.0 -9.195003 0.0 0.0 -9.197503 0.0 0.0 -9.200003 0.0 0.0 -9.202503 0.0 0.0 -9.205003 0.0 0.0 -9.207503 0.0 0.0 -9.210003 0.0 0.0 -9.212503 0.0 0.0 -9.215003 0.0 0.0 -9.217503 0.0 0.0 -9.220003 0.0 0.0 -9.222503 0.0 0.0 -9.225003 0.0 0.0 -9.227503 0.0 0.0 -9.230003 0.0 0.0 -9.232503 0.0 0.0 -9.235003 0.0 0.0 -9.237503 0.0 0.0 -9.240003 0.0 0.0 -9.242503 0.0 0.0 -9.245003 0.0 0.0 -9.247503 0.0 0.0 -9.250003 0.0 0.0 -9.252503 0.0 0.0 -9.255003 0.0 0.0 -9.257503 0.0 0.0 -9.260003 0.0 0.0 -9.262503 0.0 0.0 -9.265003 0.0 0.0 -9.267503 0.0 0.0 -9.270003 0.0 0.0 -9.272503 0.0 0.0 -9.275003 0.0 0.0 -9.277503 0.0 0.0 -9.280003 0.0 0.0 -9.282503 0.0 0.0 -9.285003 0.0 0.0 -9.287503 0.0 0.0 -9.290003 0.0 0.0 -9.292503 0.0 0.0 -9.295003 0.0 0.0 -9.297503 0.0 0.0 -9.300003 0.0 0.0 -9.302503 0.0 0.0 -9.305003 0.0 0.0 -9.307503 0.0 0.0 -9.310003 0.0 0.0 -9.312503 0.0 0.0 -9.315003 0.0 0.0 -9.317503 0.0 0.0 -9.320003 0.0 0.0 -9.322503 0.0 0.0 -9.325003 0.0 0.0 -9.327503 0.0 0.0 -9.330003 0.0 0.0 -9.332503 0.0 0.0 -9.335003 0.0 0.0 -9.337503 0.0 0.0 -9.340003 0.0 0.0 -9.342503 0.0 0.0 -9.345003 0.0 0.0 -9.347503 0.0 0.0 -9.350003 0.0 0.0 -9.352503 0.0 0.0 -9.355003 0.0 0.0 -9.357503 0.0 0.0 -9.360003 0.0 0.0 -9.362503 0.0 0.0 -9.365003 0.0 0.0 -9.367503 0.0 0.0 -9.370003 0.0 0.0 -9.372503 0.0 0.0 -9.375003 0.0 0.0 -9.377503 0.0 0.0 -9.380003 0.0 0.0 -9.382503 0.0 0.0 -9.385003 0.0 0.0 -9.387503 0.0 0.0 -9.390003 0.0 0.0 -9.392503 0.0 0.0 -9.395003 0.0 0.0 -9.397503 0.0 0.0 -9.400003 0.0 0.0 -9.402503 0.0 0.0 -9.405003 0.0 0.0 -9.407503 0.0 0.0 -9.410003 0.0 0.0 -9.412503 0.0 0.0 -9.415003 0.0 0.0 -9.417503 0.0 0.0 -9.420003 0.0 0.0 -9.422503 0.0 0.0 -9.425003 0.0 0.0 -9.427503 0.0 0.0 -9.430003 0.0 0.0 -9.432503 0.0 0.0 -9.435003 0.0 0.0 -9.437503 0.0 0.0 -9.440003 0.0 0.0 -9.442503 0.0 0.0 -9.445003 0.0 0.0 -9.447503 0.0 0.0 -9.450003 0.0 0.0 -9.452503 0.0 0.0 -9.455003 0.0 0.0 -9.457503 0.0 0.0 -9.460003 0.0 0.0 -9.462503 0.0 0.0 -9.465003 0.0 0.0 -9.467503 0.0 0.0 -9.470003 0.0 0.0 -9.472503 0.0 0.0 -9.475003 0.0 0.0 -9.477503 0.0 0.0 -9.480003 0.0 0.0 -9.482503 0.0 0.0 -9.485003 0.0 0.0 -9.487503 0.0 0.0 -9.490003 0.0 0.0 -9.492503 0.0 0.0 -9.495003 0.0 0.0 -9.497503 0.0 0.0 -9.500003 0.0 0.0 -9.502503 0.0 0.0 -9.505003 0.0 0.0 -9.507503 0.0 0.0 -9.510003 0.0 0.0 -9.512503 0.0 0.0 -9.515003 0.0 0.0 -9.517503 0.0 0.0 -9.520003 0.0 0.0 -9.522503 0.0 0.0 -9.525003 0.0 0.0 -9.527503 0.0 0.0 -9.530003 0.0 0.0 -9.532503 0.0 0.0 -9.535003 0.0 0.0 -9.537503 0.0 0.0 -9.540003 0.0 0.0 -9.542503 0.0 0.0 -9.545003 0.0 0.0 -9.547503 0.0 0.0 -9.550003 0.0 0.0 -9.552503 0.0 0.0 -9.555003 0.0 0.0 -9.557503 0.0 0.0 -9.560003 0.0 0.0 -9.562503 0.0 0.0 -9.565003 0.0 0.0 -9.567503 0.0 0.0 -9.570003 0.0 0.0 -9.572503 0.0 0.0 -9.575003 0.0 0.0 -9.577503 0.0 0.0 -9.580003 0.0 0.0 -9.582503 0.0 0.0 -9.585003 0.0 0.0 -9.587503 0.0 0.0 -9.590003 0.0 0.0 -9.592503 0.0 0.0 -9.595003 0.0 0.0 -9.597503 0.0 0.0 -9.600003 0.0 0.0 -9.602503 0.0 0.0 -9.605003 0.0 0.0 -9.607503 0.0 0.0 -9.610003 0.0 0.0 -9.612503 0.0 0.0 -9.615003 0.0 0.0 -9.617503 0.0 0.0 -9.620003 0.0 0.0 -9.622503 0.0 0.0 -9.625003 0.0 0.0 -9.627503 0.0 0.0 -9.630003 0.0 0.0 -9.632503 0.0 0.0 -9.635003 0.0 0.0 -9.637503 0.0 0.0 -9.640003 0.0 0.0 -9.642503 0.0 0.0 -9.645003 0.0 0.0 -9.647503 0.0 0.0 -9.650003 0.0 0.0 -9.652503 0.0 0.0 -9.655003 0.0 0.0 -9.657503 0.0 0.0 -9.660003 0.0 0.0 -9.662503 0.0 0.0 -9.665003 0.0 0.0 -9.667503 0.0 0.0 -9.670003 0.0 0.0 -9.672503 0.0 0.0 -9.675003 0.0 0.0 -9.677503 0.0 0.0 -9.680003 0.0 0.0 -9.682503 0.0 0.0 -9.685003 0.0 0.0 -9.687503 0.0 0.0 -9.690003 0.0 0.0 -9.692503 0.0 0.0 -9.695003 0.0 0.0 -9.697503 0.0 0.0 -9.700003 0.0 0.0 -9.702503 0.0 0.0 -9.705003 0.0 0.0 -9.707503 0.0 0.0 -9.710003 0.0 0.0 -9.712503 0.0 0.0 -9.715003 0.0 0.0 -9.717503 0.0 0.0 -9.720003 0.0 0.0 -9.722503 0.0 0.0 -9.725003 0.0 0.0 -9.727503 0.0 0.0 -9.730003 0.0 0.0 -9.732503 0.0 0.0 -9.735003 0.0 0.0 -9.737503 0.0 0.0 -9.740003 0.0 0.0 -9.742503 0.0 0.0 -9.745003 0.0 0.0 -9.747503 0.0 0.0 -9.750003 0.0 0.0 -9.752503 0.0 0.0 -9.755003 0.0 0.0 -9.757503 0.0 0.0 -9.760003 0.0 0.0 -9.762503 0.0 0.0 -9.765003 0.0 0.0 -9.767503 0.0 0.0 -9.770003 0.0 0.0 -9.772503 0.0 0.0 -9.775003 0.0 0.0 -9.777503 0.0 0.0 -9.780003 0.0 0.0 -9.782503 0.0 0.0 -9.785003 0.0 0.0 -9.787503 0.0 0.0 -9.790003 0.0 0.0 -9.792503 0.0 0.0 -9.795003 0.0 0.0 -9.797503 0.0 0.0 -9.800003 0.0 0.0 -9.802503 0.0 0.0 -9.805003 0.0 0.0 -9.807503 0.0 0.0 -9.810003 0.0 0.0 -9.812503 0.0 0.0 -9.815003 0.0 0.0 -9.817503 0.0 0.0 -9.820003 0.0 0.0 -9.822503 0.0 0.0 -9.825003 0.0 0.0 -9.827503 0.0 0.0 -9.830003 0.0 0.0 -9.832503 0.0 0.0 -9.835003 0.0 0.0 -9.837503 0.0 0.0 -9.840003 0.0 0.0 -9.842503 0.0 0.0 -9.845003 0.0 0.0 -9.847503 0.0 0.0 -9.850003 0.0 0.0 -9.852503 0.0 0.0 -9.855003 0.0 0.0 -9.857503 0.0 0.0 -9.860003 0.0 0.0 -9.862503 0.0 0.0 -9.865003 0.0 0.0 -9.867503 0.0 0.0 -9.870003 0.0 0.0 -9.872503 0.0 0.0 -9.875003 0.0 0.0 -9.877503 0.0 0.0 -9.880003 0.0 0.0 -9.882503 0.0 0.0 -9.885003 0.0 0.0 -9.887503 0.0 0.0 -9.890003 0.0 0.0 -9.892503 0.0 0.0 -9.895003 0.0 0.0 -9.897503 0.0 0.0 -9.900003 0.0 0.0 -9.902503 0.0 0.0 -9.905003 0.0 0.0 -9.907503 0.0 0.0 -9.910003 0.0 0.0 -9.912503 0.0 0.0 -9.915003 0.0 0.0 -9.917503 0.0 0.0 -9.920003 0.0 0.0 -9.922503 0.0 0.0 -9.925003 0.0 0.0 -9.927503 0.0 0.0 -9.930003 0.0 0.0 -9.932503 0.0 0.0 -9.935003 0.0 0.0 -9.937503 0.0 0.0 -9.940003 0.0 0.0 -9.942503 0.0 0.0 -9.945003 0.0 0.0 -9.947503 0.0 0.0 -9.950003 0.0 0.0 -9.952503 0.0 0.0 -9.955003 0.0 0.0 -9.957503 0.0 0.0 -9.960003 0.0 0.0 -9.962503 0.0 0.0 -9.965003 0.0 0.0 -9.967503 0.0 0.0 -9.970003 0.0 0.0 -9.972503 0.0 0.0 -9.975003 0.0 0.0 -9.977503 0.0 0.0 -9.980003 0.0 0.0 -9.982503 0.0 0.0 -9.985003 0.0 0.0 -9.987503 0.0 0.0 -9.990003 0.0 0.0 -9.992503 0.0 0.0 -9.995003 0.0 0.0 -9.997503 0.0 0.0 -10.000003 0.0 0.0 -10.002503 0.0 0.0 -10.005003 0.0 0.0 -10.007503 0.0 0.0 -10.010003 0.0 0.0 -10.012503 0.0 0.0 -10.015003 0.0 0.0 -10.017503 0.0 0.0 -10.020003 0.0 0.0 -10.022503 0.0 0.0 -10.025003 0.0 0.0 -10.027503 644.328146423 0.0 -10.030003 661.992774399 0.0 -10.032503 677.909276064 0.0 -10.035003 475.276567114 0.0 -10.037503 269.070707406 0.0 -10.040003 381.772858035 0.0 -10.042503 490.400262372 0.0 -10.045003 525.577960063 0.0 -10.047503 792.69108031 0.0 -10.050003 1132.45556046 0.0 -10.052503 1161.55965125 0.0 -10.055003 1336.49967744 0.0 -10.057503 1280.52586736 0.0 -10.060003 1175.94446625 0.0 -10.062503 1168.7875392 0.0 -10.065003 1281.15711682 0.0 -10.067503 1196.45475077 0.0 -10.070003 1279.76443177 0.0 -10.072503 983.797982129 0.0 -10.075003 819.556653247 0.0 -10.077503 679.188588569 0.0 -10.080003 593.560461249 0.0 -10.082503 505.171322906 0.0 -10.085003 514.696009822 0.0 -10.087503 559.216631569 0.0 -10.090003 586.554647742 0.0 -10.092503 644.527627382 0.0 -10.095003 664.575825074 0.0 -10.097503 697.056237044 0.0 -10.100003 732.880844966 0.0 -10.102503 741.201217954 0.0 -10.105003 752.404507054 0.0 -10.107503 753.875704904 0.0 -10.110003 743.492981888 0.0 -10.112503 734.174750196 0.0 -10.115003 707.750080362 0.0 -10.117503 693.733137606 0.0 -10.120003 664.408793006 0.0 -10.122503 652.814534842 0.0 -10.125003 633.517468984 0.0 -10.127503 607.677485309 0.0 -10.130003 595.801345543 0.0 -10.132503 576.712243716 0.0 -10.135003 564.18080848 0.0 -10.137503 560.50682365 0.0 -10.140003 552.020763332 0.0 -10.142503 546.388070228 0.0 -10.145003 535.512913754 0.0 -10.147503 534.817422475 0.0 -10.150003 528.972348869 0.0 -10.152503 529.711184879 0.0 -10.155003 525.756690372 0.0 -10.157503 525.30644174 0.0 -10.160003 519.731828343 0.0 -10.162503 522.029272157 0.0 -10.165003 514.282422727 0.0 -10.167503 510.860335816 0.0 -10.170003 515.423096786 0.0 -10.172503 513.682414917 0.0 -10.175003 510.777484758 0.0 -10.177503 514.51637592 0.0 -10.180003 515.252289919 0.0 -10.182503 525.30765955 0.0 -10.185003 531.428343024 0.0 -10.187503 537.795572027 1.59264598156 -10.190003 540.803987502 1.59564705461 -10.192503 542.432905443 0.0 -10.195003 545.435174545 0.0 -10.197503 544.083278039 0.0 -10.200003 543.419086106 0.0 -10.202503 545.982206007 0.0 -10.205003 545.07926119 0.0 -10.207503 542.694209715 0.0 -10.210003 536.767503009 0.0 -10.212503 530.086181175 0.0 -10.215003 519.675296733 0.0 -10.217503 519.821717042 0.0 -10.220003 511.308273197 0.0 -10.222503 511.915720483 0.0 -10.225003 511.915720483 0.0 -10.227503 520.542162224 0.0 -10.230003 520.868578848 0.0 -10.232503 530.4530644 0.0 -10.235003 529.89766568 0.0 -10.237503 522.006400786 0.0 -10.240003 530.031905473 0.0 -10.242503 528.399494719 0.0 -10.245003 529.234413128 0.0 -10.247503 524.272921794 0.0 -10.250003 523.639395963 0.0 -10.252503 518.454102957 0.0 -10.255003 530.08343347 0.0 -10.257503 537.413470127 0.0 -10.260003 541.925076501 0.0 -10.262503 557.919847359 0.0 -10.265003 564.122880342 0.0 -10.267503 572.434628363 0.0 -10.270003 568.964602883 0.0 -10.272503 576.520039919 0.0 -10.275003 581.521733243 0.0 -10.277503 588.055529912 0.0 -10.280003 587.738311037 0.0 -10.282503 602.53391899 0.0 -10.285003 611.885209493 0.0 -10.287503 606.551872251 0.0 -10.290003 621.012733644 0.0 -10.292503 624.656211664 0.0 -10.295003 624.98488841 0.0 -10.297503 629.245279031 0.0 -10.300003 633.34056499 0.0 -10.302503 632.184606571 0.0 -10.305003 635.771098721 0.0 -10.307503 634.354856058 0.0 -10.310003 642.898664847 0.0 -10.312503 641.824831261 0.0 -10.315003 654.845535774 0.0 -10.317503 659.846857265 0.0 -10.320003 666.925758047 0.0 -10.322503 684.042489538 0.0 -10.325003 685.178724093 0.0 -10.327503 691.324741979 0.0 -10.330003 714.635328561 0.0 -10.332503 715.28942876 0.0 -10.335003 715.347982281 0.0 -10.337503 730.016118006 0.0 -10.340003 722.510023902 0.0 -10.342503 729.991205073 0.0 -10.345003 740.68634007 0.0 -10.347503 738.00841178 0.0 -10.350003 759.702103041 0.0 -10.352503 747.82006938 0.0 -10.355003 759.487614834 0.0 -10.357503 755.16152958 0.0 -10.360003 784.310354889 0.0 -10.362503 769.336810622 0.0 -10.365003 770.603265496 0.0 -10.367503 786.059553975 0.0 -10.370003 770.656372052 0.0 -10.372503 795.710175989 0.0 -10.375003 768.80421273 0.0 -10.377503 815.078959138 0.0 -10.380003 778.757619372 0.0 -10.382503 782.537618895 0.0 -10.385003 794.452686097 0.0 -10.387503 784.481448702 0.0 -10.390003 780.372930276 0.0 -10.392503 785.736913937 0.0 -10.395003 789.306851211 0.0 -10.397503 779.925142473 0.0 -10.400003 777.04646515 0.0 -10.402503 769.005630408 0.0 -10.405003 771.397968041 0.0 -10.407503 769.216069232 0.0 -10.410003 768.543803546 0.0 -10.412503 757.79499169 0.0 -10.415003 745.889109133 0.0 -10.417503 745.651845057 0.0 -10.420003 731.500981708 0.0 -10.422503 729.960420442 0.0 -10.425003 721.286873443 0.0 -10.427503 708.120942106 0.0 -10.430003 709.115258697 0.0 -10.432503 703.059572224 0.0 -10.435003 736.414157409 0.0 -10.437503 693.553043622 0.0 -10.440003 675.781260426 0.0 -10.442503 650.642270295 0.0 -10.445003 663.353581761 0.0 -10.447503 651.239116229 0.0 -10.450003 639.826070662 0.0 -10.452503 611.398714221 0.0 -10.455003 583.978630282 0.0 -10.457503 547.030978733 0.0 -10.460003 531.955194222 0.0 -10.462503 486.649623809 0.0 -10.465003 442.116920413 0.0 -10.467503 407.978733698 0.0 -10.470003 374.024194845 0.0 -10.472503 358.790965132 0.0 -10.475003 323.83605158 0.0 -10.477503 281.063553974 0.0 -10.480003 262.255144916 0.0 -10.482503 218.811576526 0.0 -10.485003 241.743504672 0.0 -10.487503 252.009125276 0.0 -10.490003 237.39303931 0.0 -10.492503 316.244914375 0.0 -10.495003 326.965155307 0.0 -10.497503 322.100169511 0.0 -10.500003 281.097792046 0.0 -10.502503 209.404973939 0.0 -10.505003 179.297526807 0.0 -10.507503 211.905775043 0.0 -10.510003 211.839812227 0.0 -10.512503 210.511230396 0.0 -10.515003 265.771150663 0.0 -10.517503 216.263601781 0.0 -10.520003 217.052751636 0.0 -10.522503 213.051557945 0.0 -10.525003 226.034624591 0.0 -10.527503 268.034363612 0.0 -10.530003 255.531173604 0.0 -10.532503 237.974483711 0.0 -10.535003 224.219901894 0.0 -10.537503 236.730955135 0.0 -10.540003 243.754271531 0.0 -10.542503 245.410623585 0.0 -10.545003 251.043669518 0.0 -10.547503 247.68388178 0.0 -10.550003 260.852502788 0.0 -10.552503 293.938239843 0.0 -10.555003 285.18462895 0.0 -10.557503 255.941628526 0.0 -10.560003 216.117079943 0.0 -10.562503 239.627051639 0.0 -10.565003 186.083754667 0.0 -10.567503 173.8983209 0.0 -10.570003 132.918916623 0.0 -10.572503 96.97562037 0.0 -10.575003 97.9315973667 0.0 -10.577503 104.651766831 0.0 -10.580003 117.426632453 0.0 -10.582503 141.980922995 0.0 -10.585003 156.138887022 0.0 -10.587503 171.071723956 0.0 -10.590003 221.556297338 0.0 -10.592503 257.709806484 0.0 -10.595003 300.488147031 0.0 -10.597503 314.25701197 0.0 -10.600003 328.247405796 0.0 -10.602503 312.911931349 0.0 -10.605003 326.101965993 0.0 -10.607503 316.192069435 0.0 -10.610003 295.489038189 0.0 -10.612503 295.379597806 0.0 -10.615003 290.797944264 0.0 -10.617503 256.166658562 0.0 -10.620003 241.051731032 0.0 -10.622503 244.369628021 0.0 -10.625003 239.909719984 0.0 -10.627503 230.663279443 0.0 -10.630003 228.366212731 0.0 -10.632503 223.954881959 0.0 -10.635003 218.453996323 0.0 -10.637503 213.826666713 0.0 -10.640003 219.82395067 0.0 -10.642503 221.604194479 0.0 -10.645003 218.581390817 0.0 -10.647503 229.847343403 0.0 -10.650003 234.36933016 0.0 -10.652503 243.321643682 0.0 -10.655003 236.407760378 0.0 -10.657503 258.855156706 0.0 -10.660003 247.450766659 0.0 -10.662503 249.533205222 0.0 -10.665003 267.56510378 0.0 -10.667503 269.084671842 0.0 -10.670003 277.813956167 0.0 -10.672503 273.953218321 0.0 -10.675003 276.74554416 0.0 -10.677503 269.575659536 0.0 -10.680003 268.999635768 0.0 -10.682503 258.943416002 0.0 -10.685003 259.827295234 0.0 -10.687503 247.224455283 0.0 -10.690003 246.043725975 0.0 -10.692503 241.37628403 0.0 -10.695003 237.21823782 0.0 -10.697503 231.054274711 0.0 -10.700003 225.628519238 0.0 -10.702503 224.218921961 0.0 -10.705003 223.074261595 0.0 -10.707503 221.848517436 0.0 -10.710003 221.656975847 0.0 -10.712503 221.630184325 0.0 -10.715003 227.833019398 0.0 -10.717503 226.399653399 0.0 -10.720003 219.164689224 0.0 -10.722503 229.959666949 0.0 -10.725003 225.365359224 0.0 -10.727503 229.149774421 0.0 -10.730003 228.628383353 0.0 -10.732503 233.051918165 0.0 -10.735003 232.745515982 0.0 -10.737503 233.780645477 0.0 -10.740003 236.425511709 0.0 -10.742503 234.87493044 0.0 -10.745003 227.907647457 0.0 -10.747503 233.234213312 0.0 -10.750003 232.566178224 0.0 -10.752503 225.881468449 0.0 -10.755003 230.061133666 0.0 -10.757503 216.642961239 0.0 -10.760003 224.585850602 0.0 -10.762503 226.930178409 0.0 -10.765003 219.088029146 0.0 -10.767503 211.926347656 0.0 -10.770003 218.013930803 0.0 -10.772503 216.91658561 0.0 -10.775003 208.375005446 0.0 -10.777503 207.553885218 0.0 -10.780003 199.789170196 0.0 -10.782503 197.238688205 0.0 -10.785003 205.38324557 0.0 -10.787503 203.447531705 0.0 -10.790003 202.890818281 0.0 -10.792503 198.631108213 0.0 -10.795003 197.206711363 0.0 -10.797503 192.428728944 0.0 -10.800003 189.678630861 0.0 -10.802503 189.963406147 0.0 -10.805003 195.695626503 0.0 -10.807503 191.66071737 0.0 -10.810003 185.245415503 0.0 -10.812503 180.831108388 0.0 -10.815003 178.968270253 0.0 -10.817503 177.793352464 0.0 -10.820003 179.900819398 0.0 -10.822503 174.460975909 0.0 -10.825003 169.988887352 0.0 -10.827503 157.074810174 0.0 -10.830003 161.80072701 0.0 -10.832503 160.557457304 0.0 -10.835003 155.192270614 0.0 -10.837503 152.207231634 0.0 -10.840003 146.095491333 0.0 -10.842503 143.263871495 0.0 -10.845003 141.013030772 0.0 -10.847503 133.225912212 0.0 -10.850003 127.874151709 0.0 -10.852503 130.451678946 0.0 -10.855003 128.797882621 0.0 -10.857503 124.262071287 0.0 -10.860003 121.588630414 0.0 -10.862503 118.979697779 0.0 -10.865003 116.564925855 0.0 -10.867503 107.970978852 0.0 -10.870003 105.746599341 0.0 -10.872503 97.01993164 0.0 -10.875003 104.502467354 0.0 -10.877503 101.940143226 0.0 -10.880003 103.009701401 0.0 -10.882503 97.1256965685 0.0 -10.885003 85.3034743254 0.0 -10.887503 85.6805893306 0.0 -10.890003 80.8096872991 0.0 -10.892503 71.8290153934 0.0 -10.895003 83.3439245798 0.0 -10.897503 78.9503267339 0.0 -10.900003 56.9608405612 0.0 -10.902503 62.0384566384 0.0 -10.905003 67.2066345262 0.0 -10.907503 56.7931288405 0.0 -10.910003 53.9857042542 0.0 -10.912503 51.4199310688 0.0 -10.915003 46.5628389285 0.0 -10.917503 48.2018542105 0.0 -10.920003 35.2606528853 0.0 -10.922503 40.1176065981 0.0 -10.925003 40.0447425661 0.0 -10.927503 38.7506769629 0.0 -10.930003 31.2748987694 0.0 -10.932503 19.6322018566 0.0 -10.935003 28.079511515 0.0 -10.937503 13.7510534358 0.0 -10.940003 24.499362217 0.0 -10.942503 25.2133124087 0.0 -10.945003 7.55738029725 0.0 -10.947503 13.5668201082 0.0 -10.950003 1.35222231597 0.0 -10.952503 9.73813726108 0.0 -10.955003 1.51116788148 0.0 -10.957503 9.48101992413 0.0 -10.960003 -4.2821372798 0.0 -10.962503 13.6498178669 0.0 -10.965003 -0.497667927216 0.0 -10.967503 6.02379913085 0.0 -10.970003 -2.28174266962 0.0 -10.972503 -5.21767647964 0.0 -10.975003 -14.4447310933 0.0 -10.977503 -23.1669467566 0.0 -10.980003 -26.0575402207 0.0 -10.982503 -28.2696513433 0.0 -10.985003 -26.4838384596 0.0 -10.987503 -30.6219871739 0.0 -10.990003 -33.0499717747 0.0 -10.992503 -26.2930062495 0.0 -10.995003 0.0 0.0 -10.997503 0.0 0.0 -11.000003 0.0 0.0 -11.002503 0.0 0.0 -11.005003 0.0 0.0 -11.007503 0.0 0.0 -11.010003 0.0 0.0 -11.012503 0.0 0.0 -11.015003 0.0 0.0 -11.017503 0.0 0.0 -11.020003 0.0 0.0 -11.022503 0.0 0.0 -11.025003 0.0 0.0 -11.027503 0.0 0.0 -11.030003 0.0 0.0 -11.032503 0.0 0.0 -11.035003 0.0 0.0 -11.037503 0.0 0.0 -11.040003 0.0 0.0 -11.042503 0.0 0.0 -11.045003 0.0 0.0 -11.047503 0.0 0.0 -11.050003 0.0 0.0 -11.052503 0.0 0.0 -11.055003 0.0 0.0 -11.057503 0.0 0.0 -11.060003 0.0 0.0 -11.062503 0.0 0.0 -11.065003 0.0 0.0 -11.067503 0.0 0.0 -11.070003 0.0 0.0 -11.072503 0.0 0.0 -11.075003 0.0 0.0 -11.077503 0.0 0.0 -11.080003 0.0 0.0 -11.082503 0.0 0.0 -11.085003 0.0 0.0 -11.087503 0.0 0.0 -11.090003 0.0 0.0 -11.092503 0.0 0.0 -11.095003 0.0 0.0 -11.097503 0.0 0.0 -11.100003 0.0 0.0 -11.102503 0.0 0.0 -11.105003 0.0 0.0 -11.107503 0.0 0.0 -11.110003 0.0 0.0 -11.112503 0.0 0.0 -11.115003 0.0 0.0 -11.117503 0.0 0.0 -11.120003 0.0 0.0 -11.122503 0.0 0.0 -11.125003 0.0 0.0 -11.127503 0.0 0.0 -11.130003 0.0 0.0 -11.132503 0.0 0.0 -11.135003 0.0 0.0 -11.137503 0.0 0.0 -11.140003 0.0 0.0 -11.142503 0.0 0.0 -11.145003 0.0 0.0 -11.147503 0.0 0.0 -11.150003 0.0 0.0 -11.152503 0.0 0.0 -11.155003 0.0 0.0 -11.157503 0.0 0.0 -11.160003 0.0 0.0 -11.162503 0.0 0.0 -11.165003 0.0 0.0 -11.167503 0.0 0.0 -11.170003 0.0 0.0 -11.172503 0.0 0.0 -11.175003 0.0 0.0 -11.177503 0.0 0.0 -11.180003 0.0 0.0 -11.182503 0.0 0.0 -11.185003 0.0 0.0 -11.187503 0.0 0.0 -11.190003 0.0 0.0 -11.192503 0.0 0.0 -11.195003 0.0 0.0 -11.197503 0.0 0.0 -11.200003 0.0 0.0 -11.202503 0.0 0.0 -11.205003 0.0 0.0 -11.207503 0.0 0.0 -11.210003 0.0 0.0 -11.212503 0.0 0.0 -11.215003 0.0 0.0 -11.217503 0.0 0.0 -11.220003 0.0 0.0 -11.222503 0.0 0.0 -11.225003 0.0 0.0 -11.227503 0.0 0.0 -11.230003 0.0 0.0 -11.232503 0.0 0.0 -11.235003 0.0 0.0 -11.237503 0.0 0.0 -11.240003 0.0 0.0 -11.242503 0.0 0.0 -11.245003 0.0 0.0 -11.247503 0.0 0.0 -11.250003 0.0 0.0 -11.252503 0.0 0.0 -11.255003 0.0 0.0 -11.257503 0.0 0.0 -11.260003 0.0 0.0 -11.262503 0.0 0.0 -11.265003 0.0 0.0 -11.267503 0.0 0.0 -11.270003 0.0 0.0 -11.272503 0.0 0.0 -11.275003 0.0 0.0 -11.277503 0.0 0.0 -11.280003 0.0 0.0 -11.282503 0.0 0.0 -11.285003 0.0 0.0 -11.287503 0.0 0.0 -11.290003 0.0 0.0 -11.292503 0.0 0.0 -11.295003 0.0 0.0 -11.297503 0.0 0.0 -11.300003 0.0 0.0 -11.302503 0.0 0.0 -11.305003 0.0 0.0 -11.307503 0.0 0.0 -11.310003 0.0 0.0 -11.312503 0.0 0.0 -11.315003 0.0 0.0 -11.317503 0.0 0.0 -11.320003 0.0 0.0 -11.322503 0.0 0.0 -11.325003 0.0 0.0 -11.327503 0.0 0.0 -11.330003 0.0 0.0 -11.332503 0.0 0.0 -11.335003 0.0 0.0 -11.337503 0.0 0.0 -11.340003 0.0 0.0 -11.342503 0.0 0.0 -11.345003 0.0 0.0 -11.347503 0.0 0.0 -11.350003 0.0 0.0 -11.352503 0.0 0.0 -11.355003 0.0 0.0 -11.357503 0.0 0.0 -11.360003 0.0 0.0 -11.362503 0.0 0.0 -11.365003 0.0 0.0 -11.367503 0.0 0.0 -11.370003 0.0 0.0 -11.372503 0.0 0.0 -11.375003 0.0 0.0 -11.377503 0.0 0.0 -11.380003 0.0 0.0 -11.382503 0.0 0.0 -11.385003 0.0 0.0 -11.387503 0.0 0.0 -11.390003 0.0 0.0 -11.392503 0.0 0.0 -11.395003 0.0 0.0 -11.397503 0.0 0.0 -11.400003 0.0 0.0 -11.402503 0.0 0.0 -11.405003 0.0 0.0 -11.407503 0.0 0.0 -11.410003 0.0 0.0 -11.412503 0.0 0.0 -11.415003 0.0 0.0 -11.417503 0.0 0.0 -11.420003 0.0 0.0 -11.422503 0.0 0.0 -11.425003 0.0 0.0 -11.427503 0.0 0.0 -11.430003 0.0 0.0 -11.432503 0.0 0.0 -11.435003 0.0 0.0 -11.437503 0.0 0.0 -11.440003 0.0 0.0 -11.442503 0.0 0.0 -11.445003 0.0 0.0 -11.447503 0.0 0.0 -11.450003 0.0 0.0 -11.452503 0.0 0.0 -11.455003 0.0 0.0 -11.457503 0.0 0.0 -11.460003 0.0 0.0 -11.462503 0.0 0.0 -11.465003 0.0 0.0 -11.467503 0.0 0.0 -11.470003 0.0 0.0 -11.472503 0.0 0.0 -11.475003 0.0 0.0 -11.477503 0.0 0.0 -11.480003 0.0 0.0 -11.482503 0.0 0.0 -11.485003 0.0 0.0 -11.487503 0.0 0.0 -11.490003 0.0 0.0 -11.492503 0.0 0.0 -11.495003 0.0 0.0 -11.497503 0.0 0.0 -11.500003 0.0 0.0 -11.502503 0.0 0.0 -11.505003 0.0 0.0 -11.507503 0.0 0.0 -11.510003 0.0 0.0 -11.512503 0.0 0.0 -11.515003 0.0 0.0 -11.517503 0.0 0.0 -11.520003 0.0 0.0 -11.522503 0.0 0.0 -11.525003 0.0 0.0 -11.527503 0.0 0.0 -11.530003 0.0 0.0 -11.532503 0.0 0.0 -11.535003 0.0 0.0 -11.537503 0.0 0.0 -11.540003 0.0 0.0 -11.542503 0.0 0.0 -11.545003 0.0 0.0 -11.547503 0.0 0.0 -11.550003 0.0 0.0 -11.552503 0.0 0.0 -11.555003 0.0 0.0 -11.557503 0.0 0.0 -11.560003 0.0 0.0 -11.562503 0.0 0.0 -11.565003 0.0 0.0 -11.567503 0.0 0.0 -11.570003 0.0 0.0 -11.572503 0.0 0.0 -11.575003 0.0 0.0 -11.577503 0.0 0.0 -11.580003 0.0 0.0 -11.582503 0.0 0.0 -11.585003 0.0 0.0 -11.587503 0.0 0.0 -11.590003 0.0 0.0 -11.592503 0.0 0.0 -11.595003 0.0 0.0 -11.597503 0.0 0.0 -11.600003 0.0 0.0 -11.602503 0.0 0.0 -11.605003 0.0 0.0 -11.607503 0.0 0.0 -11.610003 0.0 0.0 -11.612503 0.0 0.0 -11.615003 0.0 0.0 -11.617503 0.0 0.0 -11.620003 0.0 0.0 -11.622503 0.0 0.0 -11.625003 0.0 0.0 -11.627503 0.0 0.0 -11.630003 0.0 0.0 -11.632503 0.0 0.0 -11.635003 0.0 0.0 -11.637503 0.0 0.0 -11.640003 0.0 0.0 -11.642503 0.0 0.0 -11.645003 0.0 0.0 -11.647503 0.0 0.0 -11.650003 0.0 0.0 -11.652503 0.0 0.0 -11.655003 0.0 0.0 -11.657503 0.0 0.0 -11.660003 0.0 0.0 -11.662503 0.0 0.0 -11.665003 0.0 0.0 -11.667503 0.0 0.0 -11.670003 0.0 0.0 -11.672503 0.0 0.0 -11.675003 0.0 0.0 -11.677503 0.0 0.0 -11.680003 0.0 0.0 -11.682503 0.0 0.0 -11.685003 0.0 0.0 -11.687503 0.0 0.0 -11.690003 0.0 0.0 -11.692503 0.0 0.0 -11.695003 0.0 0.0 -11.697503 0.0 0.0 -11.700003 0.0 0.0 -11.702503 0.0 0.0 -11.705003 0.0 0.0 -11.707503 0.0 0.0 -11.710003 0.0 0.0 -11.712503 0.0 0.0 -11.715003 0.0 0.0 -11.717503 0.0 0.0 -11.720003 0.0 0.0 -11.722503 0.0 0.0 -11.725003 0.0 0.0 -11.727503 0.0 0.0 -11.730003 0.0 0.0 -11.732503 0.0 0.0 -11.735003 0.0 0.0 -11.737503 0.0 0.0 -11.740003 0.0 0.0 -11.742503 0.0 0.0 -11.745003 0.0 0.0 -11.747503 0.0 0.0 -11.750003 0.0 0.0 -11.752503 0.0 0.0 -11.755003 0.0 0.0 -11.757503 0.0 0.0 -11.760003 0.0 0.0 -11.762503 0.0 0.0 -11.765003 0.0 0.0 -11.767503 0.0 0.0 -11.770003 0.0 0.0 -11.772503 0.0 0.0 -11.775003 0.0 0.0 -11.777503 0.0 0.0 -11.780003 0.0 0.0 -11.782503 0.0 0.0 -11.785003 0.0 0.0 -11.787503 0.0 0.0 -11.790003 0.0 0.0 -11.792503 0.0 0.0 -11.795003 0.0 0.0 -11.797503 0.0 0.0 -11.800003 0.0 0.0 -11.802503 0.0 0.0 -11.805003 0.0 0.0 -11.807503 0.0 0.0 -11.810003 0.0 0.0 -11.812503 0.0 0.0 -11.815003 0.0 0.0 -11.817503 0.0 0.0 -11.820003 0.0 0.0 -11.822503 0.0 0.0 -11.825003 0.0 0.0 -11.827503 0.0 0.0 -11.830003 0.0 0.0 -11.832503 0.0 0.0 -11.835003 0.0 0.0 -11.837503 0.0 0.0 -11.840003 0.0 0.0 -11.842503 0.0 0.0 -11.845003 0.0 0.0 -11.847503 0.0 0.0 -11.850003 0.0 0.0 -11.852503 0.0 0.0 -11.855003 0.0 0.0 -11.857503 0.0 0.0 -11.860003 0.0 0.0 -11.862503 0.0 0.0 -11.865003 0.0 0.0 -11.867503 0.0 0.0 -11.870003 0.0 0.0 -11.872503 0.0 0.0 -11.875003 0.0 0.0 -11.877503 0.0 0.0 -11.880003 0.0 0.0 -11.882503 0.0 0.0 -11.885003 0.0 0.0 -11.887503 0.0 0.0 -11.890003 0.0 0.0 -11.892503 0.0 0.0 -11.895003 0.0 0.0 -11.897503 0.0 0.0 -11.900003 0.0 0.0 -11.902503 0.0 0.0 -11.905003 0.0 0.0 -11.907503 -132.019563965 0.0 -11.910003 29.8552501756 0.0 -11.912503 172.955435444 0.0 -11.915003 154.199237175 0.0 -11.917503 312.409924095 0.0 -11.920003 250.149626714 0.0 -11.922503 188.434568618 0.0 -11.925003 204.266591976 0.0 -11.927503 376.976154565 0.0 -11.930003 586.22101636 0.0 -11.932503 852.341167215 0.0 -11.935003 931.381801912 0.0 -11.937503 918.15238807 0.0 -11.940003 919.372369466 0.0 -11.942503 1057.76863352 0.0 -11.945003 1171.87918325 0.0 -11.947503 1263.26470312 0.0 -11.950003 1455.34715365 0.0 -11.952503 1450.4593133 0.0 -11.955003 1367.28386929 0.0 -11.957503 1436.09958352 0.0 -11.960003 1501.69721056 0.0 -11.962503 1498.37903554 0.0 -11.965003 1496.89752706 0.0 -11.967503 1466.29827132 0.0 -11.970003 1315.14135255 0.0 -11.972503 1118.17448523 0.0 -11.975003 985.684112169 0.0 -11.977503 902.828389233 0.0 -11.980003 836.067586216 0.0 -11.982503 793.805644072 0.0 -11.985003 708.110636249 0.0 -11.987503 633.56115173 0.0 -11.990003 614.335983126 0.0 -11.992503 590.363398207 0.0 -11.995003 545.632102453 0.0 -11.997503 522.158987808 0.0 -12.000003 499.745024556 0.0 -12.002503 477.542125278 0.0 -12.005003 478.177678983 0.0 -12.007503 463.293568973 0.0 -12.010003 460.937638164 0.0 -12.012503 476.264446791 0.0 -12.015003 476.357626474 0.0 -12.017503 487.99125134 0.0 -12.020003 501.116103273 0.0 -12.022503 510.11351433 0.0 -12.025003 513.795050847 0.0 -12.027503 516.001805474 0.0 -12.030003 524.355153614 0.0 -12.032503 523.131410365 0.0 -12.035003 509.251244721 0.0 -12.037503 508.896152117 0.0 -12.040003 504.695868384 0.0 -12.042503 496.602080314 0.0 -12.045003 494.061835838 0.0 -12.047503 485.624351337 0.0 -12.050003 485.985045583 0.0 -12.052503 487.687568661 0.0 -12.055003 485.892975609 0.0 -12.057503 481.911183857 0.0 -12.060003 483.180280592 0.0 -12.062503 486.976884757 0.0 -12.065003 490.071629415 0.0 -12.067503 494.061774301 0.0 -12.070003 502.220557587 0.0 -12.072503 503.107843043 1.33725700679 -12.075003 506.637106956 1.34786139825 -12.077503 504.665710729 1.34386882119 -12.080003 508.456385991 0.0 -12.082503 507.470989894 0.0 -12.085003 505.858072525 0.0 -12.087503 503.216614021 0.0 -12.090003 498.929609615 0.0 -12.092503 502.449200444 0.0 -12.095003 500.505044782 0.0 -12.097503 503.32311172 1.6110613091 -12.100003 501.106042511 0.0 -12.102503 505.419944722 0.0 -12.105003 509.140174195 0.0 -12.107503 512.735863728 0.0 -12.110003 515.700268158 0.0 -12.112503 523.636075887 0.0 -12.115003 525.401670717 0.0 -12.117503 528.905554206 0.0 -12.120003 534.995066932 0.0 -12.122503 541.384348212 0.0 -12.125003 550.687819222 0.0 -12.127503 559.118564557 0.0 -12.130003 562.517166772 0.0 -12.132503 566.946019379 0.0 -12.135003 568.698659041 0.0 -12.137503 572.788385646 0.0 -12.140003 573.348880049 0.0 -12.142503 575.728317793 0.0 -12.145003 574.012623919 0.0 -12.147503 577.286284171 0.0 -12.150003 581.384797027 0.0 -12.152503 583.209419201 0.0 -12.155003 586.300789468 0.0 -12.157503 589.70921032 0.0 -12.160003 594.302077395 0.0 -12.162503 600.256718467 0.0 -12.165003 610.145819989 0.0 -12.167503 613.672859193 0.0 -12.170003 613.717266423 0.0 -12.172503 620.390872722 0.0 -12.175003 615.761894053 0.0 -12.177503 615.761894053 0.0 -12.180003 639.598150647 0.0 -12.182503 640.032336252 0.0 -12.185003 637.718744999 0.0 -12.187503 645.020116824 0.0 -12.190003 652.803762474 0.0 -12.192503 659.026644678 0.0 -12.195003 665.462237879 0.0 -12.197503 667.637730892 0.0 -12.200003 675.488998755 0.0 -12.202503 682.040353624 0.0 -12.205003 682.821110166 0.0 -12.207503 683.494987341 0.0 -12.210003 687.307112746 0.0 -12.212503 690.150933891 0.0 -12.215003 691.474364893 0.0 -12.217503 690.983151195 0.0 -12.220003 694.858905215 12.7978982597 -12.222503 697.502111556 0.0 -12.225003 697.269008191 0.0 -12.227503 708.808805937 0.0 -12.230003 717.309437794 0.0 -12.232503 738.890964499 0.0 -12.235003 762.833983618 0.0 -12.237503 745.445993536 0.0 -12.240003 773.596627537 0.0 -12.242503 786.744406366 0.0 -12.245003 776.830026382 0.0 -12.247503 816.769232316 0.0 -12.250003 824.90648955 0.0 -12.252503 829.155498808 0.0 -12.255003 851.13916888 0.0 -12.257503 841.013951415 0.0 -12.260003 850.804747369 0.0 -12.262503 863.092331929 0.0 -12.265003 845.360574651 0.0 -12.267503 829.561995966 0.0 -12.270003 819.998461856 0.0 -12.272503 832.151146177 0.0 -12.275003 821.668456821 0.0 -12.277503 832.391613206 0.0 -12.280003 822.453176201 0.0 -12.282503 834.427706214 0.0 -12.285003 837.203728772 0.0 -12.287503 827.387502509 0.0 -12.290003 834.985833871 0.0 -12.292503 831.094692459 0.0 -12.295003 825.200585592 0.0 -12.297503 821.328019112 0.0 -12.300003 829.057323846 0.0 -12.302503 823.824084712 0.0 -12.305003 818.909603156 0.0 -12.307503 825.903221231 0.0 -12.310003 815.226188797 0.0 -12.312503 795.979449901 0.0 -12.315003 781.776036811 0.0 -12.317503 771.914400825 0.0 -12.320003 757.604414674 0.0 -12.322503 731.292873042 0.0 -12.325003 719.828903606 0.0 -12.327503 695.156940525 0.0 -12.330003 701.171784208 0.0 -12.332503 683.25488142 0.0 -12.335003 683.997396135 0.0 -12.337503 655.799246923 0.0 -12.340003 666.582828342 0.0 -12.342503 655.625355967 0.0 -12.345003 689.990509801 0.0 -12.347503 674.626897346 0.0 -12.350003 661.627412569 0.0 -12.352503 645.49461916 0.0 -12.355003 624.112190235 0.0 -12.357503 608.1105382 0.0 -12.360003 582.327600009 0.0 -12.362503 553.811676744 0.0 -12.365003 533.735148959 0.0 -12.367503 507.525467829 0.0 -12.370003 491.607746126 0.0 -12.372503 464.919131224 0.0 -12.375003 434.821810504 0.0 -12.377503 418.273071548 0.0 -12.380003 415.656002193 0.0 -12.382503 403.678795156 0.0 -12.385003 390.444758483 0.0 -12.387503 384.773822154 0.0 -12.390003 365.923369746 0.0 -12.392503 389.099851709 0.0 -12.395003 373.468797343 0.0 -12.397503 358.230004585 0.0 -12.400003 370.59566269 0.0 -12.402503 406.472834989 0.0 -12.405003 456.352940981 0.0 -12.407503 460.119624002 0.0 -12.410003 480.388612267 0.0 -12.412503 483.952241959 0.0 -12.415003 489.743716954 0.0 -12.417503 463.88547772 0.0 -12.420003 474.061591718 0.0 -12.422503 485.376830474 0.0 -12.425003 485.411681049 0.0 -12.427503 534.087715488 0.0 -12.430003 534.087715488 0.0 -12.432503 448.602812446 0.0 -12.435003 429.824073979 0.0 -12.437503 390.281315051 0.0 -12.440003 387.227930505 0.0 -12.442503 402.016395961 0.0 -12.445003 339.664139077 0.0 -12.447503 345.277509476 0.0 -12.450003 340.496359372 0.0 -12.452503 333.556328905 0.0 -12.455003 319.990440469 0.0 -12.457503 325.39068733 0.0 -12.460003 333.516569308 0.0 -12.462503 338.753979559 0.0 -12.465003 332.203546025 0.0 -12.467503 330.218095479 0.0 -12.470003 329.547544778 0.0 -12.472503 322.8025288 0.0 -12.475003 320.127950413 0.0 -12.477503 314.772526838 0.0 -12.480003 314.110359222 0.0 -12.482503 307.33776307 0.0 -12.485003 310.896337853 0.0 -12.487503 305.32184798 0.0 -12.490003 298.38971359 0.0 -12.492503 301.420928775 0.0 -12.495003 295.031828942 0.0 -12.497503 290.840688563 0.0 -12.500003 298.653229222 0.0 -12.502503 300.574113575 0.0 -12.505003 291.512544753 0.0 -12.507503 288.322016044 0.0 -12.510003 277.527323199 0.0 -12.512503 300.344849249 0.0 -12.515003 294.454692948 0.0 -12.517503 290.294020616 0.0 -12.520003 297.107410794 0.0 -12.522503 289.515333092 0.0 -12.525003 282.827393773 0.0 -12.527503 283.360115044 0.0 -12.530003 278.030533504 0.0 -12.532503 273.489840913 0.0 -12.535003 263.911763309 0.0 -12.537503 270.82047215 0.0 -12.540003 264.896696569 0.0 -12.542503 262.741089836 0.0 -12.545003 255.174173446 0.0 -12.547503 250.71143272 0.0 -12.550003 251.408262553 0.0 -12.552503 242.667703878 0.0 -12.555003 242.974885318 0.0 -12.557503 245.755172064 0.0 -12.560003 245.755172064 0.0 -12.562503 252.215140878 0.0 -12.565003 262.859681782 0.0 -12.567503 258.304034728 0.0 -12.570003 253.122410875 0.0 -12.572503 256.163929164 0.0 -12.575003 258.745054405 0.0 -12.577503 264.252455666 0.0 -12.580003 260.89898687 0.0 -12.582503 259.627649084 0.0 -12.585003 258.684218177 0.0 -12.587503 257.814950402 0.0 -12.590003 252.580346565 0.0 -12.592503 247.011835361 0.0 -12.595003 245.985324059 0.0 -12.597503 248.73924774 0.0 -12.600003 244.071773629 0.0 -12.602503 240.159174746 0.0 -12.605003 236.338993459 0.0 -12.607503 227.638022013 0.0 -12.610003 233.283497126 0.0 -12.612503 230.629594543 0.0 -12.615003 230.629594543 0.0 -12.617503 224.891639659 0.0 -12.620003 224.745681701 0.0 -12.622503 223.539458015 0.0 -12.625003 223.959365917 0.0 -12.627503 220.049230139 0.0 -12.630003 226.540503599 0.0 -12.632503 218.737016965 0.0 -12.635003 218.317055487 0.0 -12.637503 217.545391754 0.0 -12.640003 210.870441348 0.0 -12.642503 206.447947316 0.0 -12.645003 209.519140071 0.0 -12.647503 207.754213245 0.0 -12.650003 197.233029768 0.0 -12.652503 196.344878652 0.0 -12.655003 193.859810218 0.0 -12.657503 198.908375935 0.0 -12.660003 190.349333466 0.0 -12.662503 190.349333466 0.0 -12.665003 194.161680518 0.0 -12.667503 190.691297112 0.0 -12.670003 184.772437737 0.0 -12.672503 193.545832433 0.0 -12.675003 189.479706835 0.0 -12.677503 187.934814981 0.0 -12.680003 180.100426782 0.0 -12.682503 181.60837494 0.0 -12.685003 175.243533222 0.0 -12.687503 177.639803231 0.0 -12.690003 170.311539922 0.0 -12.692503 175.03490475 0.0 -12.695003 165.385917378 0.0 -12.697503 175.55696934 0.0 -12.700003 174.573946589 0.0 -12.702503 172.355404928 0.0 -12.705003 169.388632897 0.0 -12.707503 168.978401 0.0 -12.710003 169.030020303 0.0 -12.712503 171.696062794 0.0 -12.715003 176.955061571 0.0 -12.717503 176.851250024 0.0 -12.720003 173.939022181 0.0 -12.722503 179.817289812 0.0 -12.725003 170.972596892 0.0 -12.727503 173.596850505 0.0 -12.730003 175.664981863 0.0 -12.732503 192.187215243 0.0 -12.735003 187.146263545 0.0 -12.737503 182.541959857 0.0 -12.740003 193.388871663 0.0 -12.742503 194.227540437 0.0 -12.745003 195.343551412 0.0 -12.747503 192.501755137 0.0 -12.750003 188.381430048 0.0 -12.752503 185.94768667 0.0 -12.755003 180.943252904 0.0 -12.757503 168.21749213 0.0 -12.760003 170.743120644 0.0 -12.762503 178.295790194 0.0 -12.765003 177.047134863 0.0 -12.767503 175.384601574 0.0 -12.770003 175.961655708 0.0 -12.772503 174.63584287 0.0 -12.775003 169.807915506 0.0 -12.777503 164.235960817 0.0 -12.780003 171.840115451 0.0 -12.782503 176.599356621 0.0 -12.785003 174.435633161 0.0 -12.787503 169.642031894 0.0 -12.790003 167.986878669 0.0 -12.792503 163.704538861 0.0 -12.795003 165.957610242 0.0 -12.797503 162.157520606 0.0 -12.800003 156.910425968 0.0 -12.802503 150.658422849 0.0 -12.805003 144.808698909 0.0 -12.807503 140.33124648 0.0 -12.810003 121.428522107 0.0 -12.812503 124.337516925 0.0 -12.815003 118.486551559 0.0 -12.817503 118.282324626 0.0 -12.820003 109.925924801 0.0 -12.822503 107.042185125 0.0 -12.825003 103.919758124 0.0 -12.827503 107.934348222 0.0 -12.830003 106.604717075 0.0 -12.832503 102.228983653 0.0 -12.835003 96.5038655875 0.0 -12.837503 92.0303010721 0.0 -12.840003 90.6197813459 0.0 -12.842503 91.8349482099 0.0 -12.845003 84.0427592615 0.0 -12.847503 83.5752482739 0.0 -12.850003 86.0333076617 0.0 -12.852503 82.6551361604 0.0 -12.855003 81.1710342858 0.0 -12.857503 77.3321016478 0.0 -12.860003 76.7555425018 0.0 -12.862503 76.5519651217 0.0 -12.865003 71.2843864229 0.0 -12.867503 67.7344814116 0.0 -12.870003 60.8599119354 0.0 -12.872503 60.8331904734 0.0 -12.875003 54.0826329923 0.0 -12.877503 53.8557315971 0.0 -12.880003 51.9659426372 0.0 -12.882503 36.5493801844 0.0 -12.885003 36.8711302891 0.0 -12.887503 33.3223862543 0.0 -12.890003 31.0112553516 0.0 -12.892503 24.8668381205 0.0 -12.895003 31.9766649626 0.0 -12.897503 16.1455770389 0.0 -12.900003 -0.247768113922 0.0 -12.902503 -3.43748834969 0.0 -12.905003 0.0286250663546 0.0 -12.907503 -5.56947974707 0.0 -12.910003 -4.08901793383 0.0 -12.912503 -6.291942485 0.0 -12.915003 -12.8937822638 0.0 -12.917503 -10.7098869383 0.0 -12.920003 -28.4341059609 0.0 -12.922503 0.0 0.0 -12.925003 0.0 0.0 -12.927503 0.0 0.0 -12.930003 0.0 0.0 -12.932503 0.0 0.0 -12.935003 0.0 0.0 -12.937503 0.0 0.0 -12.940003 0.0 0.0 -12.942503 0.0 0.0 -12.945003 0.0 0.0 -12.947503 0.0 0.0 -12.950003 0.0 0.0 -12.952503 0.0 0.0 -12.955003 0.0 0.0 -12.957503 0.0 0.0 -12.960003 0.0 0.0 -12.962503 0.0 0.0 -12.965003 0.0 0.0 -12.967503 0.0 0.0 -12.970003 0.0 0.0 -12.972503 0.0 0.0 -12.975003 0.0 0.0 -12.977503 0.0 0.0 -12.980003 0.0 0.0 -12.982503 0.0 0.0 -12.985003 0.0 0.0 -12.987503 0.0 0.0 -12.990003 0.0 0.0 -12.992503 0.0 0.0 -12.995003 0.0 0.0 -12.997503 0.0 0.0 -13.000003 0.0 0.0 -13.002503 0.0 0.0 -13.005003 0.0 0.0 -13.007503 0.0 0.0 -13.010003 0.0 0.0 -13.012503 0.0 0.0 -13.015003 0.0 0.0 -13.017503 0.0 0.0 -13.020003 0.0 0.0 -13.022503 0.0 0.0 -13.025003 0.0 0.0 -13.027503 0.0 0.0 -13.030003 0.0 0.0 -13.032503 0.0 0.0 -13.035003 0.0 0.0 -13.037503 0.0 0.0 -13.040003 0.0 0.0 -13.042503 0.0 0.0 -13.045003 0.0 0.0 -13.047503 0.0 0.0 -13.050003 0.0 0.0 -13.052503 0.0 0.0 -13.055003 0.0 0.0 -13.057503 0.0 0.0 -13.060003 0.0 0.0 -13.062503 0.0 0.0 -13.065003 0.0 0.0 -13.067503 0.0 0.0 -13.070003 0.0 0.0 -13.072503 0.0 0.0 -13.075003 0.0 0.0 -13.077503 0.0 0.0 -13.080003 0.0 0.0 -13.082503 0.0 0.0 -13.085003 0.0 0.0 -13.087503 0.0 0.0 -13.090003 0.0 0.0 -13.092503 0.0 0.0 -13.095003 0.0 0.0 -13.097503 0.0 0.0 -13.100003 0.0 0.0 -13.102503 0.0 0.0 -13.105003 0.0 0.0 -13.107503 0.0 0.0 -13.110003 0.0 0.0 -13.112503 0.0 0.0 -13.115003 0.0 0.0 -13.117503 0.0 0.0 -13.120003 0.0 0.0 -13.122503 0.0 0.0 -13.125003 0.0 0.0 -13.127503 0.0 0.0 -13.130003 0.0 0.0 -13.132503 0.0 0.0 -13.135003 0.0 0.0 -13.137503 0.0 0.0 -13.140003 0.0 0.0 -13.142503 0.0 0.0 -13.145003 0.0 0.0 -13.147503 0.0 0.0 -13.150003 0.0 0.0 -13.152503 0.0 0.0 -13.155003 0.0 0.0 -13.157503 0.0 0.0 -13.160003 0.0 0.0 -13.162503 0.0 0.0 -13.165003 0.0 0.0 -13.167503 0.0 0.0 -13.170003 0.0 0.0 -13.172503 0.0 0.0 -13.175003 0.0 0.0 -13.177503 0.0 0.0 -13.180003 0.0 0.0 -13.182503 0.0 0.0 -13.185003 0.0 0.0 -13.187503 0.0 0.0 -13.190003 0.0 0.0 -13.192503 0.0 0.0 -13.195003 0.0 0.0 -13.197503 0.0 0.0 -13.200003 0.0 0.0 -13.202503 0.0 0.0 -13.205003 0.0 0.0 -13.207503 0.0 0.0 -13.210003 0.0 0.0 -13.212503 0.0 0.0 -13.215003 0.0 0.0 -13.217503 0.0 0.0 -13.220003 0.0 0.0 -13.222503 0.0 0.0 -13.225003 0.0 0.0 -13.227503 0.0 0.0 -13.230003 0.0 0.0 -13.232503 0.0 0.0 -13.235003 0.0 0.0 -13.237503 0.0 0.0 -13.240003 0.0 0.0 -13.242503 0.0 0.0 -13.245003 0.0 0.0 -13.247503 0.0 0.0 -13.250003 0.0 0.0 -13.252503 0.0 0.0 -13.255003 0.0 0.0 -13.257503 0.0 0.0 -13.260003 0.0 0.0 -13.262503 0.0 0.0 -13.265003 0.0 0.0 -13.267503 0.0 0.0 -13.270003 0.0 0.0 -13.272503 0.0 0.0 -13.275003 0.0 0.0 -13.277503 0.0 0.0 -13.280003 0.0 0.0 -13.282503 0.0 0.0 -13.285003 0.0 0.0 -13.287503 0.0 0.0 -13.290003 0.0 0.0 -13.292503 0.0 0.0 -13.295003 0.0 0.0 -13.297503 0.0 0.0 -13.300003 0.0 0.0 -13.302503 0.0 0.0 -13.305003 0.0 0.0 -13.307503 0.0 0.0 -13.310003 0.0 0.0 -13.312503 0.0 0.0 -13.315003 0.0 0.0 -13.317503 0.0 0.0 -13.320003 0.0 0.0 -13.322503 0.0 0.0 -13.325003 0.0 0.0 -13.327503 0.0 0.0 -13.330003 0.0 0.0 -13.332503 0.0 0.0 -13.335003 0.0 0.0 -13.337503 0.0 0.0 -13.340003 0.0 0.0 -13.342503 0.0 0.0 -13.345003 0.0 0.0 -13.347503 0.0 0.0 -13.350003 0.0 0.0 -13.352503 0.0 0.0 -13.355003 0.0 0.0 -13.357503 0.0 0.0 -13.360003 0.0 0.0 -13.362503 0.0 0.0 -13.365003 0.0 0.0 -13.367503 0.0 0.0 -13.370003 0.0 0.0 -13.372503 0.0 0.0 -13.375003 0.0 0.0 -13.377503 0.0 0.0 -13.380003 0.0 0.0 -13.382503 0.0 0.0 -13.385003 0.0 0.0 -13.387503 0.0 0.0 -13.390003 0.0 0.0 -13.392503 0.0 0.0 -13.395003 0.0 0.0 -13.397503 0.0 0.0 -13.400003 0.0 0.0 -13.402503 0.0 0.0 -13.405003 0.0 0.0 -13.407503 0.0 0.0 -13.410003 0.0 0.0 -13.412503 0.0 0.0 -13.415003 0.0 0.0 -13.417503 0.0 0.0 -13.420003 0.0 0.0 -13.422503 0.0 0.0 -13.425003 0.0 0.0 -13.427503 0.0 0.0 -13.430003 0.0 0.0 -13.432503 0.0 0.0 -13.435003 0.0 0.0 -13.437503 0.0 0.0 -13.440003 0.0 0.0 -13.442503 0.0 0.0 -13.445003 0.0 0.0 -13.447503 0.0 0.0 -13.450003 0.0 0.0 -13.452503 0.0 0.0 -13.455003 0.0 0.0 -13.457503 0.0 0.0 -13.460003 0.0 0.0 -13.462503 0.0 0.0 -13.465003 0.0 0.0 -13.467503 0.0 0.0 -13.470003 0.0 0.0 -13.472503 0.0 0.0 -13.475003 0.0 0.0 -13.477503 0.0 0.0 -13.480003 0.0 0.0 -13.482503 0.0 0.0 -13.485003 0.0 0.0 -13.487503 0.0 0.0 -13.490003 0.0 0.0 -13.492503 0.0 0.0 -13.495003 0.0 0.0 -13.497503 0.0 0.0 -13.500003 0.0 0.0 -13.502503 0.0 0.0 -13.505003 0.0 0.0 -13.507503 0.0 0.0 -13.510003 0.0 0.0 -13.512503 0.0 0.0 -13.515003 0.0 0.0 -13.517503 0.0 0.0 -13.520003 0.0 0.0 -13.522503 0.0 0.0 -13.525003 0.0 0.0 -13.527503 0.0 0.0 -13.530003 0.0 0.0 -13.532503 0.0 0.0 -13.535003 0.0 0.0 -13.537503 0.0 0.0 -13.540003 0.0 0.0 -13.542503 0.0 0.0 -13.545003 0.0 0.0 -13.547503 0.0 0.0 -13.550003 0.0 0.0 -13.552503 0.0 0.0 -13.555003 0.0 0.0 -13.557503 0.0 0.0 -13.560003 0.0 0.0 -13.562503 0.0 0.0 -13.565003 0.0 0.0 -13.567503 0.0 0.0 -13.570003 0.0 0.0 -13.572503 0.0 0.0 -13.575003 0.0 0.0 -13.577503 0.0 0.0 -13.580003 0.0 0.0 -13.582503 0.0 0.0 -13.585003 0.0 0.0 -13.587503 0.0 0.0 -13.590003 0.0 0.0 -13.592503 0.0 0.0 -13.595003 0.0 0.0 -13.597503 0.0 0.0 -13.600003 0.0 0.0 -13.602503 0.0 0.0 -13.605003 0.0 0.0 -13.607503 0.0 0.0 -13.610003 0.0 0.0 -13.612503 0.0 0.0 -13.615003 0.0 0.0 -13.617503 0.0 0.0 -13.620003 0.0 0.0 -13.622503 0.0 0.0 -13.625003 0.0 0.0 -13.627503 0.0 0.0 -13.630003 0.0 0.0 -13.632503 0.0 0.0 -13.635003 0.0 0.0 -13.637503 0.0 0.0 -13.640003 0.0 0.0 -13.642503 0.0 0.0 -13.645003 0.0 0.0 -13.647503 0.0 0.0 -13.650003 0.0 0.0 -13.652503 0.0 0.0 -13.655003 0.0 0.0 -13.657503 0.0 0.0 -13.660003 0.0 0.0 -13.662503 0.0 0.0 -13.665003 0.0 0.0 -13.667503 0.0 0.0 -13.670003 0.0 0.0 -13.672503 0.0 0.0 -13.675003 0.0 0.0 -13.677503 0.0 0.0 -13.680003 0.0 0.0 -13.682503 0.0 0.0 -13.685003 0.0 0.0 -13.687503 0.0 0.0 -13.690003 0.0 0.0 -13.692503 0.0 0.0 -13.695003 0.0 0.0 -13.697503 0.0 0.0 -13.700003 0.0 0.0 -13.702503 0.0 0.0 -13.705003 0.0 0.0 -13.707503 0.0 0.0 -13.710003 0.0 0.0 -13.712503 0.0 0.0 -13.715003 0.0 0.0 -13.717503 0.0 0.0 -13.720003 0.0 0.0 -13.722503 0.0 0.0 -13.725003 0.0 0.0 -13.727503 0.0 0.0 -13.730003 0.0 0.0 -13.732503 0.0 0.0 -13.735003 0.0 0.0 -13.737503 0.0 0.0 -13.740003 0.0 0.0 -13.742503 0.0 0.0 -13.745003 0.0 0.0 -13.747503 0.0 0.0 -13.750003 0.0 0.0 -13.752503 0.0 0.0 -13.755003 0.0 0.0 -13.757503 0.0 0.0 -13.760003 0.0 0.0 -13.762503 0.0 0.0 -13.765003 0.0 0.0 -13.767503 0.0 0.0 -13.770003 0.0 0.0 -13.772503 0.0 0.0 -13.775003 0.0 0.0 -13.777503 0.0 0.0 -13.780003 0.0 0.0 -13.782503 0.0 0.0 -13.785003 0.0 0.0 -13.787503 0.0 0.0 -13.790003 0.0 0.0 -13.792503 0.0 0.0 -13.795003 0.0 0.0 -13.797503 0.0 0.0 -13.800003 0.0 0.0 -13.802503 0.0 0.0 -13.805003 0.0 0.0 -13.807503 0.0 0.0 -13.810003 0.0 0.0 -13.812503 0.0 0.0 -13.815003 0.0 0.0 -13.817503 0.0 0.0 -13.820003 0.0 0.0 -13.822503 0.0 0.0 -13.825003 0.0 0.0 -13.827503 -40.5687432108 0.0 -13.830003 0.0 0.0 -13.832503 578.666508755 0.0 -13.835003 652.223804775 0.0 -13.837503 588.271485764 0.0 -13.840003 818.218643681 0.0 -13.842503 1344.96936684 0.0 -13.845003 1782.80892883 0.0 -13.847503 2100.38665194 0.0 -13.850003 2070.86082672 0.0 -13.852503 1867.68701846 0.0 -13.855003 1528.18259956 0.0 -13.857503 1530.12390538 0.0 -13.860003 1459.91327853 0.0 -13.862503 1308.45706432 0.0 -13.865003 1262.383281 0.0 -13.867503 1321.73463226 0.0 -13.870003 1270.00778183 0.0 -13.872503 1203.69643807 0.0 -13.875003 1080.69804595 0.0 -13.877503 1035.84154908 0.0 -13.880003 1024.55842033 0.0 -13.882503 1031.29570472 0.0 -13.885003 1071.707444 0.0 -13.887503 1079.78792677 0.0 -13.890003 1089.92168198 0.0 -13.892503 1091.44648473 0.0 -13.895003 1030.87219881 0.0 -13.897503 861.15323863 0.0 -13.900003 846.589259992 0.0 -13.902503 822.621617971 0.0 -13.905003 833.691245227 0.0 -13.907503 852.603758824 0.0 -13.910003 847.149892898 0.0 -13.912503 860.110284635 0.0 -13.915003 838.519842467 0.0 -13.917503 852.063124305 0.0 -13.920003 786.415907338 0.0 -13.922503 703.274554704 0.0 -13.925003 661.567678942 0.0 -13.927503 540.048409637 0.0 -13.930003 419.574724152 0.0 -13.932503 423.101047261 0.0 -13.935003 441.111627825 0.0 -13.937503 513.174418274 0.0 -13.940003 609.627936849 0.0 -13.942503 667.686847076 0.0 -13.945003 723.688915757 0.0 -13.947503 582.11439561 0.0 -13.950003 697.411154692 0.0 -13.952503 739.543272904 0.0 -13.955003 655.016341577 0.0 -13.957503 681.558928946 0.0 -13.960003 699.077602741 0.0 -13.962503 714.245302753 0.0 -13.965003 711.553897768 0.0 -13.967503 703.984402913 0.0 -13.970003 632.790885656 -15.94894576 -13.972503 591.154828384 -3.49945854875 -13.975003 542.472254219 -1.16764379024 -13.977503 505.3475868 -0.750129802554 -13.980003 465.2953561 0.0 -13.982503 470.192065685 0.0 -13.985003 472.647109167 0.0 -13.987503 500.014493961 0.0 -13.990003 527.110049661 0.0 -13.992503 558.707309037 0.0 -13.995003 571.006859958 0.0 -13.997503 586.882701346 0.0 -14.000003 535.149014678 0.0 -14.002503 531.218360958 0.0 -14.005003 531.34939701 0.0 -14.007503 542.858292621 0.0 -14.010003 551.683462955 0.0 -14.012503 573.92984371 0.0 -14.015003 459.160396158 0.0 -14.017503 451.619324259 0.0 -14.020003 405.738869585 1.7216209103 -14.022503 378.909420753 0.0 -14.025003 398.085894729 0.0 -14.027503 403.972640066 0.0 -14.030003 436.18486565 0.0 -14.032503 481.054533065 0.0 -14.035003 511.26306439 0.0 -14.037503 530.971792511 0.0 -14.040003 554.820451566 0.0 -14.042503 548.38972094 0.0 -14.045003 500.862884896 0.0 -14.047503 485.471737607 0.0 -14.050003 445.691521939 0.0 -14.052503 456.769535924 0.0 -14.055003 488.391988845 0.0 -14.057503 534.992784395 0.0 -14.060003 584.883475613 0.0 -14.062503 626.63953563 0.0 -14.065003 641.277447559 0.0 -14.067503 661.938524744 0.0 -14.070003 692.116121035 0.0 -14.072503 665.618857313 0.0 -14.075003 628.877729395 -3.50549578246 -14.077503 599.456258327 -3.4568768272 -14.080003 539.31522339 -1.96790623673 -14.082503 489.605972433 -3.3760784491 -14.085003 157.184688539 -0.0405487440759 -14.087503 142.748248508 -0.60437951716 -14.090003 221.138970734 0.0 -14.092503 254.762605889 10.6997243134 -14.095003 362.340455626 24.0372959236 -14.097503 444.139624089 15.556885214 -14.100003 521.875182747 13.8180590762 -14.102503 602.179176358 16.443562584 -14.105003 689.796752959 11.2206543242 -14.107503 740.528296519 16.8105060029 -14.110003 727.153924542 24.644516595 -14.112503 771.538895415 18.0952657118 -14.115003 766.258956358 27.4735666673 -14.117503 586.404037668 39.3975297205 -14.120003 657.96134278 37.1365464782 -14.122503 670.572744743 41.7206363309 -14.125003 693.536224004 0.347237279524 -14.127503 673.033960518 1.58732776567 -14.130003 712.525913624 6.44851151631 -14.132503 712.20417096 -1.49444854933 -14.135003 690.597408761 4.06661767643 -14.137503 736.848334359 0.0 -14.140003 735.18333312 0.0 -14.142503 740.519359443 0.0 -14.145003 756.574126205 0.0 -14.147503 698.350625559 0.0 -14.150003 176.986423256 0.261527981123 -14.152503 179.685806918 0.238165213328 -14.155003 356.972481872 0.0 -14.157503 512.007496914 0.0 -14.160003 621.514066762 0.0 -14.162503 655.896040047 0.0 -14.165003 747.524077062 0.0 -14.167503 789.799969447 0.0 -14.170003 791.022837127 0.0 -14.172503 777.758928953 0.0 -14.175003 679.88687498 0.0 -14.177503 636.519020673 0.0 -14.180003 616.553906226 0.0 -14.182503 621.739246298 0.0 -14.185003 646.374768425 0.0 -14.187503 667.794055135 0.0 -14.190003 685.534321333 0.0 -14.192503 732.515160188 0.0 -14.195003 767.99383342 0.0 -14.197503 811.210846184 0.0 -14.200003 873.713220918 0.0 -14.202503 907.361219011 0.0 -14.205003 953.452163158 0.0 -14.207503 946.635508958 0.0 -14.210003 996.532179572 0.0 -14.212503 1008.71949295 0.0 -14.215003 1007.7438391 0.0 -14.217503 973.393117388 0.0 -14.220003 933.760075876 0.0 -14.222503 866.251748296 0.0 -14.225003 804.386245885 0.0 -14.227503 778.661986684 0.0 -14.230003 743.852737029 0.0 -14.232503 705.27017114 0.0 -14.235003 671.994730706 0.0 -14.237503 648.317877556 0.0 -14.240003 648.317877556 0.0 -14.242503 668.182734999 0.0 -14.245003 665.118797967 0.0 -14.247503 572.419266778 0.0 -14.250003 586.653994606 0.0 -14.252503 614.708775782 0.0 -14.255003 641.908034482 0.0 -14.257503 668.733535169 0.0 -14.260003 674.342266666 0.0 -14.262503 656.518988553 0.0 -14.265003 628.381453638 0.0 -14.267503 615.334062304 0.0 -14.270003 575.769839163 0.0 -14.272503 571.922669422 0.0 -14.275003 603.833201712 0.0 -14.277503 610.893846915 0.0 -14.280003 631.495199532 0.0 -14.282503 720.16035157 0.0 -14.285003 716.155482525 0.0 -14.287503 714.158175108 0.0 -14.290003 663.563109754 0.0 -14.292503 612.337456221 0.0 -14.295003 565.230825409 0.0 -14.297503 476.693659873 0.0 -14.300003 471.253979832 0.0 -14.302503 447.110277104 0.0 -14.305003 441.348473231 0.0 -14.307503 395.873576073 0.0 -14.310003 358.487369936 0.0 -14.312503 297.903463709 0.0 -14.315003 271.330723793 0.0 -14.317503 277.89485751 0.0 -14.320003 315.560597286 0.0 -14.322503 264.590698949 0.0 -14.325003 315.284992523 0.0 -14.327503 306.84477442 0.0 -14.330003 322.54035143 0.0 -14.332503 306.1334176 0.0 -14.335003 452.217926889 0.0 -14.337503 374.29570158 0.0 -14.340003 386.113418661 0.0 -14.342503 359.620876686 0.0 -14.345003 319.709051504 0.0 -14.347503 295.752833778 0.0 -14.350003 220.478453679 0.0 -14.352503 173.51139726 0.0 -14.355003 184.812664353 0.0 -14.357503 184.897097644 0.0 -14.360003 195.398465493 0.0 -14.362503 196.982961884 0.0 -14.365003 205.26178832 0.0 -14.367503 212.402515673 0.0 -14.370003 221.86410194 0.0 -14.372503 218.126869489 0.0 -14.375003 218.728171966 0.0 -14.377503 203.693516039 0.0 -14.380003 193.593288746 0.0 -14.382503 206.840380068 0.0 -14.385003 194.736806432 0.0 -14.387503 190.924768647 0.0 -14.390003 197.919787549 0.0 -14.392503 135.904705137 0.0 -14.395003 156.973554437 0.0 -14.397503 166.952112919 0.0 -14.400003 160.03833281 0.0 -14.402503 158.923436853 0.0 -14.405003 179.325266161 0.0 -14.407503 187.065644427 0.0 -14.410003 170.938788799 0.0 -14.412503 147.736249546 0.0 -14.415003 126.618219806 0.0 -14.417503 137.81402338 0.0 -14.420003 150.274232572 0.0 -14.422503 141.139347183 0.0 -14.425003 148.866075569 0.0 -14.427503 176.52103755 0.0 -14.430003 169.137020623 0.0 -14.432503 167.607826691 0.0 -14.435003 225.514976641 0.0 -14.437503 208.470910438 0.0 -14.440003 163.820624484 0.0 -14.442503 168.282303582 0.0 -14.445003 168.282303582 0.0 -14.447503 149.12834447 0.0 -14.450003 163.907001881 0.0 -14.452503 164.42152129 0.0 -14.455003 166.484674308 0.0 -14.457503 142.429324144 0.0 -14.460003 123.12231621 0.0 -14.462503 120.109039076 0.0 -14.465003 95.6588357194 0.0 -14.467503 85.2187004546 0.0 -14.470003 82.2366281904 0.0 -14.472503 99.5595548918 0.0 -14.475003 73.9464693417 0.0 -14.477503 90.7017120033 0.0 -14.480003 93.2381213401 0.0 -14.482503 75.9921983879 0.0 -14.485003 96.6675564283 0.0 -14.487503 85.2536551454 0.0 -14.490003 95.8348361713 0.0 -14.492503 124.092541664 0.0 -14.495003 121.647571673 0.0 -14.497503 118.898469362 0.0 -14.500003 114.7941367 0.0 -14.502503 126.379492735 0.0 -14.505003 167.532239397 0.0 -14.507503 155.614990506 0.0 -14.510003 136.929404768 0.0 -14.512503 158.264092113 0.0 -14.515003 157.681779757 0.0 -14.517503 161.029692868 0.0 -14.520003 148.45806572 0.0 -14.522503 166.249387782 0.0 -14.525003 196.079117377 0.0 -14.527503 205.732788218 0.0 -14.530003 198.284876203 0.0 -14.532503 213.605154416 0.0 -14.535003 237.790646198 0.0 -14.537503 233.979042412 0.0 -14.540003 213.984889399 0.0 -14.542503 212.976503208 0.0 -14.545003 227.136813284 0.0 -14.547503 232.453962743 0.0 -14.550003 245.533676913 0.0 -14.552503 237.017568647 0.0 -14.555003 215.570663603 0.0 -14.557503 177.820303297 0.0 -14.560003 180.555082073 0.0 -14.562503 189.83822648 0.0 -14.565003 190.8001148 0.0 -14.567503 197.998223771 0.0 -14.570003 208.659534957 0.0 -14.572503 209.219955478 0.0 -14.575003 224.49835523 0.0 -14.577503 220.596728854 0.0 -14.580003 192.609692411 0.0 -14.582503 198.533563844 0.0 -14.585003 193.150090405 0.0 -14.587503 124.961443126 0.0 -14.590003 177.909885523 0.0 -14.592503 184.438429839 0.0 -14.595003 200.37063577 0.0 -14.597503 208.86174367 0.0 -14.600003 230.650796796 0.0 -14.602503 241.55538871 0.0 -14.605003 237.699729456 0.0 -14.607503 243.797319448 0.0 -14.610003 267.061619915 0.0 -14.612503 283.811718302 0.0 -14.615003 283.811718302 0.0 -14.617503 272.988118348 0.0 -14.620003 263.848368056 0.0 -14.622503 262.648082469 0.0 -14.625003 194.568856673 0.0 -14.627503 238.025905211 0.0 -14.630003 227.089499045 0.0 -14.632503 205.29442754 0.0 -14.635003 202.694938661 0.0 -14.637503 207.279412785 0.0 -14.640003 212.318989642 0.0 -14.642503 216.221527256 0.0 -14.645003 237.007043746 0.0 -14.647503 256.47192782 0.0 -14.650003 251.850316769 0.0 -14.652503 247.027130379 0.0 -14.655003 266.562542602 0.0 -14.657503 270.330915482 0.0 -14.660003 271.630231669 0.0 -14.662503 279.971634207 0.0 -14.665003 255.845839581 0.0 -14.667503 244.230532517 0.0 -14.670003 234.960858254 0.0 -14.672503 243.255633073 0.0 -14.675003 237.031533569 0.0 -14.677503 240.169515201 0.0 -14.680003 235.453007546 0.0 -14.682503 238.688941168 0.0 -14.685003 221.804152095 0.0 -14.687503 210.493540485 0.0 -14.690003 211.433200677 0.0 -14.692503 200.058564288 0.0 -14.695003 201.264232113 0.0 -14.697503 174.027260191 0.0 -14.700003 170.622616249 0.0 -14.702503 182.194647154 0.0 -14.705003 169.791785621 0.0 -14.707503 175.930459904 0.0 -14.710003 176.225183058 0.0 -14.712503 183.597679884 0.0 -14.715003 194.711005688 0.0 -14.717503 192.262708947 0.0 -14.720003 198.794999927 0.0 -14.722503 177.983750071 0.0 -14.725003 172.739724933 0.0 -14.727503 146.687171329 0.0 -14.730003 122.80700692 0.0 -14.732503 139.765626463 0.0 -14.735003 144.888006219 0.0 -14.737503 139.358259461 0.0 -14.740003 136.16554231 0.0 -14.742503 124.401027049 0.0 -14.745003 124.401027049 0.0 -14.747503 139.997917116 0.0 -14.750003 163.750146916 0.0 -14.752503 137.551665802 0.0 -14.755003 146.410195249 0.0 -14.757503 148.887896182 0.0 -14.760003 146.687631715 0.0 -14.762503 132.132928084 0.0 -14.765003 133.970973699 0.0 -14.767503 149.196777059 0.0 -14.770003 140.266512301 0.0 -14.772503 120.513405686 0.0 -14.775003 89.8606937694 0.0 -14.777503 81.7165399562 0.0 -14.780003 81.4217083188 0.0 -14.782503 67.5948133953 0.0 -14.785003 80.7301159452 0.0 -14.787503 97.318178784 0.0 -14.790003 97.8773374882 0.0 -14.792503 84.9238430347 0.0 -14.795003 74.2834064869 0.0 -14.797503 61.3005846415 0.0 -14.800003 65.7596407213 0.0 -14.802503 54.9564415636 0.0 -14.805003 53.3671823988 0.0 -14.807503 53.3671823988 0.0 -14.810003 38.1952988293 0.0 -14.812503 38.1952988293 0.0 -14.815003 31.1251414755 0.0 -14.817503 31.1251414755 0.0 -14.820003 5.18529893887 0.0 -14.822503 9.40465353957 0.0 -14.825003 6.45365240775 0.0 -14.827503 -9.52712842699 0.0 -14.830003 -28.1948339247 0.0 -14.832503 0.0 0.0 -14.835003 0.0 0.0 -14.837503 0.0 0.0 -14.840003 0.0 0.0 -14.842503 0.0 0.0 -14.845003 0.0 0.0 -14.847503 0.0 0.0 -14.850003 0.0 0.0 -14.852503 0.0 0.0 -14.855003 0.0 0.0 -14.857503 0.0 0.0 -14.860003 0.0 0.0 -14.862503 0.0 0.0 -14.865003 0.0 0.0 -14.867503 0.0 0.0 -14.870003 0.0 0.0 -14.872503 0.0 0.0 -14.875003 0.0 0.0 -14.877503 0.0 0.0 -14.880003 0.0 0.0 -14.882503 0.0 0.0 -14.885003 0.0 0.0 -14.887503 0.0 0.0 -14.890003 0.0 0.0 -14.892503 0.0 0.0 -14.895003 0.0 0.0 -14.897503 0.0 0.0 -14.900003 0.0 0.0 -14.902503 0.0 0.0 -14.905003 0.0 0.0 -14.907503 0.0 0.0 -14.910003 0.0 0.0 -14.912503 0.0 0.0 -14.915003 0.0 0.0 -14.917503 0.0 0.0 -14.920003 0.0 0.0 -14.922503 0.0 0.0 -14.925003 0.0 0.0 -14.927503 0.0 0.0 -14.930003 0.0 0.0 -14.932503 0.0 0.0 -14.935003 0.0 0.0 -14.937503 0.0 0.0 -14.940003 0.0 0.0 -14.942503 0.0 0.0 -14.945003 0.0 0.0 -14.947503 0.0 0.0 -14.950003 0.0 0.0 -14.952503 0.0 0.0 -14.955003 0.0 0.0 -14.957503 0.0 0.0 -14.960003 0.0 0.0 -14.962503 0.0 0.0 -14.965003 0.0 0.0 -14.967503 0.0 0.0 -14.970003 0.0 0.0 -14.972503 0.0 0.0 -14.975003 0.0 0.0 -14.977503 0.0 0.0 -14.980003 0.0 0.0 -14.982503 0.0 0.0 -14.985003 0.0 0.0 -14.987503 0.0 0.0 -14.990003 0.0 0.0 -14.992503 0.0 0.0 -14.995003 0.0 0.0 -14.997503 0.0 0.0 -15.000003 0.0 0.0 -15.002503 0.0 0.0 -15.005003 0.0 0.0 -15.007503 0.0 0.0 -15.010003 0.0 0.0 -15.012503 0.0 0.0 -15.015003 0.0 0.0 -15.017503 0.0 0.0 -15.020003 0.0 0.0 -15.022503 0.0 0.0 -15.025003 0.0 0.0 -15.027503 0.0 0.0 -15.030003 0.0 0.0 -15.032503 0.0 0.0 -15.035003 0.0 0.0 -15.037503 0.0 0.0 -15.040003 0.0 0.0 -15.042503 0.0 0.0 -15.045003 0.0 0.0 -15.047503 0.0 0.0 -15.050003 0.0 0.0 -15.052503 0.0 0.0 -15.055003 0.0 0.0 -15.057503 0.0 0.0 -15.060003 0.0 0.0 -15.062503 0.0 0.0 -15.065003 0.0 0.0 -15.067503 0.0 0.0 -15.070003 0.0 0.0 -15.072503 0.0 0.0 -15.075003 0.0 0.0 -15.077503 0.0 0.0 -15.080003 0.0 0.0 -15.082503 0.0 0.0 -15.085003 0.0 0.0 -15.087503 0.0 0.0 -15.090003 0.0 0.0 -15.092503 0.0 0.0 -15.095003 0.0 0.0 -15.097503 0.0 0.0 -15.100003 0.0 0.0 -15.102503 0.0 0.0 -15.105003 0.0 0.0 -15.107503 0.0 0.0 -15.110003 0.0 0.0 -15.112503 0.0 0.0 -15.115003 0.0 0.0 -15.117503 0.0 0.0 -15.120003 0.0 0.0 -15.122503 0.0 0.0 -15.125003 0.0 0.0 -15.127503 0.0 0.0 -15.130003 0.0 0.0 -15.132503 0.0 0.0 -15.135003 0.0 0.0 -15.137503 0.0 0.0 -15.140003 0.0 0.0 -15.142503 0.0 0.0 -15.145003 0.0 0.0 -15.147503 0.0 0.0 -15.150003 0.0 0.0 -15.152503 0.0 0.0 -15.155003 0.0 0.0 -15.157503 0.0 0.0 -15.160003 0.0 0.0 -15.162503 0.0 0.0 -15.165003 0.0 0.0 -15.167503 0.0 0.0 -15.170003 0.0 0.0 -15.172503 0.0 0.0 -15.175003 0.0 0.0 -15.177503 0.0 0.0 -15.180003 0.0 0.0 -15.182503 0.0 0.0 -15.185003 0.0 0.0 -15.187503 0.0 0.0 -15.190003 0.0 0.0 -15.192503 0.0 0.0 -15.195003 0.0 0.0 -15.197503 0.0 0.0 -15.200003 0.0 0.0 -15.202503 0.0 0.0 -15.205003 0.0 0.0 -15.207503 0.0 0.0 -15.210003 0.0 0.0 -15.212503 0.0 0.0 -15.215003 0.0 0.0 -15.217503 0.0 0.0 -15.220003 0.0 0.0 -15.222503 0.0 0.0 -15.225003 0.0 0.0 -15.227503 0.0 0.0 -15.230003 0.0 0.0 -15.232503 0.0 0.0 -15.235003 0.0 0.0 -15.237503 0.0 0.0 -15.240003 0.0 0.0 -15.242503 0.0 0.0 -15.245003 0.0 0.0 -15.247503 0.0 0.0 -15.250003 0.0 0.0 -15.252503 0.0 0.0 -15.255003 0.0 0.0 -15.257503 0.0 0.0 -15.260003 0.0 0.0 -15.262503 0.0 0.0 -15.265003 0.0 0.0 -15.267503 0.0 0.0 -15.270003 0.0 0.0 -15.272503 0.0 0.0 -15.275003 0.0 0.0 -15.277503 0.0 0.0 -15.280003 0.0 0.0 -15.282503 0.0 0.0 -15.285003 0.0 0.0 -15.287503 0.0 0.0 -15.290003 0.0 0.0 -15.292503 0.0 0.0 -15.295003 0.0 0.0 -15.297503 0.0 0.0 -15.300003 0.0 0.0 -15.302503 0.0 0.0 -15.305003 0.0 0.0 -15.307503 0.0 0.0 -15.310003 0.0 0.0 -15.312503 0.0 0.0 -15.315003 0.0 0.0 -15.317503 0.0 0.0 -15.320003 0.0 0.0 -15.322503 0.0 0.0 -15.325003 0.0 0.0 -15.327503 0.0 0.0 -15.330003 0.0 0.0 -15.332503 0.0 0.0 -15.335003 0.0 0.0 -15.337503 0.0 0.0 -15.340003 0.0 0.0 -15.342503 0.0 0.0 -15.345003 0.0 0.0 -15.347503 0.0 0.0 -15.350003 0.0 0.0 -15.352503 0.0 0.0 -15.355003 0.0 0.0 -15.357503 0.0 0.0 -15.360003 0.0 0.0 -15.362503 0.0 0.0 -15.365003 0.0 0.0 -15.367503 0.0 0.0 -15.370003 0.0 0.0 -15.372503 0.0 0.0 -15.375003 0.0 0.0 -15.377503 0.0 0.0 -15.380003 0.0 0.0 -15.382503 0.0 0.0 -15.385003 0.0 0.0 -15.387503 0.0 0.0 -15.390003 0.0 0.0 -15.392503 0.0 0.0 -15.395003 0.0 0.0 -15.397503 0.0 0.0 -15.400003 0.0 0.0 -15.402503 0.0 0.0 -15.405003 0.0 0.0 -15.407503 0.0 0.0 -15.410003 0.0 0.0 -15.412503 0.0 0.0 -15.415003 0.0 0.0 -15.417503 0.0 0.0 -15.420003 0.0 0.0 -15.422503 0.0 0.0 -15.425003 0.0 0.0 -15.427503 0.0 0.0 -15.430003 0.0 0.0 -15.432503 0.0 0.0 -15.435003 0.0 0.0 -15.437503 0.0 0.0 -15.440003 0.0 0.0 -15.442503 0.0 0.0 -15.445003 0.0 0.0 -15.447503 0.0 0.0 -15.450003 0.0 0.0 -15.452503 0.0 0.0 -15.455003 0.0 0.0 -15.457503 0.0 0.0 -15.460003 0.0 0.0 -15.462503 0.0 0.0 -15.465003 0.0 0.0 -15.467503 0.0 0.0 -15.470003 0.0 0.0 -15.472503 0.0 0.0 -15.475003 0.0 0.0 -15.477503 0.0 0.0 -15.480003 0.0 0.0 -15.482503 0.0 0.0 -15.485003 0.0 0.0 -15.487503 0.0 0.0 -15.490003 0.0 0.0 -15.492503 0.0 0.0 -15.495003 0.0 0.0 -15.497503 0.0 0.0 -15.500003 0.0 0.0 -15.502503 0.0 0.0 -15.505003 0.0 0.0 -15.507503 0.0 0.0 -15.510003 0.0 0.0 -15.512503 0.0 0.0 -15.515003 0.0 0.0 -15.517503 0.0 0.0 -15.520003 0.0 0.0 -15.522503 0.0 0.0 -15.525003 0.0 0.0 -15.527503 0.0 0.0 -15.530003 0.0 0.0 -15.532503 0.0 0.0 -15.535003 0.0 0.0 -15.537503 0.0 0.0 -15.540003 0.0 0.0 -15.542503 0.0 0.0 -15.545003 0.0 0.0 -15.547503 0.0 0.0 -15.550003 0.0 0.0 -15.552503 0.0 0.0 -15.555003 0.0 0.0 -15.557503 0.0 0.0 -15.560003 0.0 0.0 -15.562503 0.0 0.0 -15.565003 0.0 0.0 -15.567503 0.0 0.0 -15.570003 0.0 0.0 -15.572503 0.0 0.0 -15.575003 0.0 0.0 -15.577503 0.0 0.0 -15.580003 0.0 0.0 -15.582503 0.0 0.0 -15.585003 0.0 0.0 -15.587503 0.0 0.0 -15.590003 0.0 0.0 -15.592503 0.0 0.0 -15.595003 0.0 0.0 -15.597503 0.0 0.0 -15.600003 0.0 0.0 -15.602503 0.0 0.0 -15.605003 0.0 0.0 -15.607503 0.0 0.0 -15.610003 0.0 0.0 -15.612503 0.0 0.0 -15.615003 0.0 0.0 -15.617503 0.0 0.0 -15.620003 0.0 0.0 -15.622503 0.0 0.0 -15.625003 0.0 0.0 -15.627503 0.0 0.0 -15.630003 0.0 0.0 -15.632503 0.0 0.0 -15.635003 0.0 0.0 -15.637503 0.0 0.0 -15.640003 0.0 0.0 -15.642503 0.0 0.0 -15.645003 0.0 0.0 -15.647503 0.0 0.0 -15.650003 0.0 0.0 -15.652503 0.0 0.0 -15.655003 0.0 0.0 -15.657503 0.0 0.0 -15.660003 0.0 0.0 -15.662503 0.0 0.0 -15.665003 0.0 0.0 -15.667503 0.0 0.0 -15.670003 0.0 0.0 -15.672503 0.0 0.0 -15.675003 0.0 0.0 -15.677503 0.0 0.0 -15.680003 0.0 0.0 -15.682503 0.0 0.0 -15.685003 0.0 0.0 -15.687503 0.0 0.0 -15.690003 0.0 0.0 -15.692503 0.0 0.0 -15.695003 0.0 0.0 -15.697503 0.0 0.0 -15.700003 0.0 0.0 -15.702503 0.0 0.0 -15.705003 0.0 0.0 -15.707503 0.0 0.0 -15.710003 0.0 0.0 -15.712503 0.0 0.0 -15.715003 0.0 0.0 -15.717503 0.0 0.0 -15.720003 0.0 0.0 -15.722503 0.0 0.0 -15.725003 0.0 0.0 -15.727503 0.0 0.0 -15.730003 0.0 0.0 -15.732503 0.0 0.0 -15.735003 0.0 0.0 -15.737503 0.0 0.0 -15.740003 0.0 0.0 -15.742503 0.0 0.0 -15.745003 0.0 0.0 -15.747503 0.0 0.0 -15.750003 0.0 0.0 -15.752503 0.0 0.0 -15.755003 0.0 0.0 -15.757503 0.0 0.0 -15.760003 0.0 0.0 -15.762503 0.0 0.0 -15.765003 0.0 0.0 -15.767503 0.0 0.0 -15.770003 0.0 0.0 -15.772503 0.0 0.0 -15.775003 0.0 0.0 -15.777503 0.0 0.0 -15.780003 0.0 0.0 -15.782503 588.982286195 0.0 -15.785003 619.900913929 0.0 -15.787503 667.215604165 0.0 -15.790003 700.740026942 0.0 -15.792503 574.454646961 0.0 -15.795003 861.248332875 0.0 -15.797503 1255.37816549 0.0 -15.800003 1503.42357836 0.0 -15.802503 1421.82735049 0.0 -15.805003 1227.6444624 0.0 -15.807503 1054.85284739 0.0 -15.810003 1016.94373092 0.0 -15.812503 952.594764393 0.0 -15.815003 908.929730269 0.0 -15.817503 836.701594047 0.0 -15.820003 825.891218974 0.0 -15.822503 754.539852817 0.0 -15.825003 742.25924272 0.0 -15.827503 702.671396114 0.0 -15.830003 694.000726414 0.0 -15.832503 650.864411312 0.0 -15.835003 656.048011759 0.0 -15.837503 655.077210986 0.0 -15.840003 648.305187996 0.0 -15.842503 652.860067688 0.0 -15.845003 662.69285203 0.0 -15.847503 664.774915355 0.0 -15.850003 691.917849002 0.0 -15.852503 715.253577708 0.0 -15.855003 733.874444294 0.0 -15.857503 746.438006837 0.0 -15.860003 759.850540641 0.0 -15.862503 777.114151899 0.0 -15.865003 788.475324189 0.0 -15.867503 792.716313248 0.0 -15.870003 794.272928872 0.0 -15.872503 792.738346475 0.0 -15.875003 786.226431142 0.0 -15.877503 772.58287948 0.0 -15.880003 757.020169601 0.0 -15.882503 741.575598425 0.0 -15.885003 711.29074918 0.0 -15.887503 692.645544471 0.0 -15.890003 670.985030854 0.0 -15.892503 649.068954388 0.0 -15.895003 628.486329298 0.0 -15.897503 612.787214505 0.0 -15.900003 597.069683489 0.0 -15.902503 592.439443263 0.0 -15.905003 584.832636551 0.0 -15.907503 583.457365477 0.0 -15.910003 578.165166951 0.0 -15.912503 573.663371774 0.0 -15.915003 576.937179072 0.0 -15.917503 580.70270557 2.40168082976 -15.920003 585.827815392 0.0 -15.922503 589.383125342 0.0 -15.925003 594.641326764 0.0 -15.927503 601.592543932 0.0 -15.930003 604.978380273 0.0 -15.932503 613.237652101 0.0 -15.935003 619.814509368 0.0 -15.937503 623.10029993 0.0 -15.940003 626.610055822 0.0 -15.942503 627.730055142 0.0 -15.945003 632.728485096 0.0 -15.947503 631.315345744 0.0 -15.950003 633.913985321 0.0 -15.952503 632.656669592 0.0 -15.955003 630.291816585 0.0 -15.957503 627.908082958 0.0 -15.960003 625.133185628 0.0 -15.962503 625.424279751 0.0 -15.965003 619.617458658 0.0 -15.967503 619.159388084 0.0 -15.970003 619.377337147 0.0 -15.972503 615.791078841 0.0 -15.975003 616.289706683 0.0 -15.977503 615.173585969 0.0 -15.980003 612.329811442 0.0 -15.982503 615.472097959 0.0 -15.985003 616.728172698 0.0 -15.987503 617.609206963 0.0 -15.990003 623.284965205 0.0 -15.992503 627.988149988 0.0 -15.995003 628.729542624 0.0 -15.997503 629.938234761 0.0 -16.000003 636.706343818 0.0 -16.002503 641.608763248 0.0 -16.005003 645.487976343 0.0 -16.007503 648.498502148 0.0 -16.010003 653.203577293 0.0 -16.012503 660.167219463 0.0 -16.015003 663.449336133 0.0 -16.017503 668.594643289 0.0 -16.020003 673.991159981 0.0 -16.022503 676.296271802 0.0 -16.025003 683.126197687 0.0 -16.027503 683.037715232 0.0 -16.030003 691.777023762 0.0 -16.032503 694.851381575 0.0 -16.035003 696.521642181 0.0 -16.037503 703.54909962 0.0 -16.040003 715.290258162 0.0 -16.042503 711.012129629 0.0 -16.045003 725.72162645 0.0 -16.047503 724.26588825 0.0 -16.050003 734.031225333 0.0 -16.052503 733.274324194 0.0 -16.055003 745.317705368 0.0 -16.057503 746.848570731 0.0 -16.060003 757.677405957 0.0 -16.062503 762.12060119 0.0 -16.065003 762.970562421 0.0 -16.067503 767.907679608 0.0 -16.070003 771.938201745 0.0 -16.072503 780.491395794 0.0 -16.075003 787.426405954 0.0 -16.077503 789.22826558 0.0 -16.080003 788.336573932 0.0 -16.082503 798.472862599 0.0 -16.085003 800.612192425 0.0 -16.087503 804.786418116 0.34511514838 -16.090003 807.931672318 0.0 -16.092503 809.826358399 0.0 -16.095003 806.549883231 0.0 -16.097503 802.171397112 0.0 -16.100003 801.336069086 0.0 -16.102503 793.666217257 0.0 -16.105003 789.069309516 0.0 -16.107503 778.314201594 0.0 -16.110003 789.279201799 0.0 -16.112503 783.015161498 0.0 -16.115003 777.325282785 0.0 -16.117503 790.481486907 0.0 -16.120003 783.299810395 0.0 -16.122503 784.617127379 0.0 -16.125003 794.145482022 0.0 -16.127503 789.096449215 0.0 -16.130003 788.790397679 0.0 -16.132503 795.329882244 0.0 -16.135003 811.892295716 0.0 -16.137503 806.620333932 0.0 -16.140003 792.923144458 0.0 -16.142503 794.738759808 0.0 -16.145003 819.18311387 0.0 -16.147503 801.818749834 0.0 -16.150003 798.437618114 0.0 -16.152503 790.197277965 0.0 -16.155003 797.243356705 0.0 -16.157503 795.916118638 0.0 -16.160003 784.906510244 0.0 -16.162503 795.679501579 0.0 -16.165003 771.957453271 0.0 -16.167503 767.856504556 0.0 -16.170003 752.700936875 0.0 -16.172503 736.109522381 0.0 -16.175003 732.126319862 0.0 -16.177503 716.279503745 0.0 -16.180003 680.378749276 0.0 -16.182503 677.263536373 0.0 -16.185003 645.947472443 0.0 -16.187503 616.249706879 0.0 -16.190003 582.736546643 0.0 -16.192503 591.482100506 0.0 -16.195003 581.150863208 0.0 -16.197503 539.713289162 0.0 -16.200003 495.309661955 0.0 -16.202503 505.219508608 0.0 -16.205003 466.704632783 0.0 -16.207503 401.167054975 0.0 -16.210003 386.935272797 0.0 -16.212503 402.042446314 0.0 -16.215003 415.332290028 0.0 -16.217503 378.595484272 0.0 -16.220003 373.755134147 0.0 -16.222503 397.914516645 0.0 -16.225003 423.665510813 0.0 -16.227503 391.734253215 0.0 -16.230003 412.152714697 0.0 -16.232503 417.213401824 0.0 -16.235003 435.364045122 0.0 -16.237503 679.448016381 0.0 -16.240003 772.7175816 0.0 -16.242503 727.07282871 0.0 -16.245003 628.376215667 0.0 -16.247503 596.392431203 0.0 -16.250003 634.112993993 0.0 -16.252503 495.189303925 0.0 -16.255003 467.699591796 0.0 -16.257503 374.582038943 0.0 -16.260003 332.000404103 0.0 -16.262503 248.333981135 0.0 -16.265003 216.579687077 0.0 -16.267503 176.235088066 0.0 -16.270003 191.492448562 0.0 -16.272503 140.016659663 0.0 -16.275003 168.804349302 0.0 -16.277503 153.111880386 0.0 -16.280003 169.851487851 0.0 -16.282503 185.011728449 0.0 -16.285003 210.326891948 0.0 -16.287503 248.536860207 0.0 -16.290003 302.568422285 0.0 -16.292503 297.574760035 0.0 -16.295003 294.746848621 0.0 -16.297503 275.637917858 0.0 -16.300003 281.306468428 0.0 -16.302503 287.078410978 0.0 -16.305003 331.478755478 0.0 -16.307503 332.73427082 0.0 -16.310003 345.022139238 0.0 -16.312503 346.093801346 0.0 -16.315003 357.200662906 0.0 -16.317503 355.903540076 0.0 -16.320003 359.048072701 0.0 -16.322503 343.236929279 0.0 -16.325003 332.930779346 0.0 -16.327503 320.57952289 0.0 -16.330003 315.812950946 0.0 -16.332503 298.731471073 0.0 -16.335003 287.999009349 0.0 -16.337503 289.825563794 0.0 -16.340003 269.979605162 0.0 -16.342503 262.817775211 0.0 -16.345003 260.581052283 0.0 -16.347503 267.02114463 0.0 -16.350003 259.702562212 0.0 -16.352503 265.628094189 0.0 -16.355003 269.127202601 0.0 -16.357503 285.949837622 0.0 -16.360003 277.496638777 0.0 -16.362503 285.256359748 0.0 -16.365003 283.830817715 0.0 -16.367503 275.686172378 0.0 -16.370003 283.129616378 0.0 -16.372503 286.874279274 0.0 -16.375003 298.567702945 0.0 -16.377503 293.455514483 0.0 -16.380003 293.037206898 0.0 -16.382503 298.14585324 0.0 -16.385003 302.758759379 0.0 -16.387503 301.259119975 0.0 -16.390003 296.909900597 0.0 -16.392503 286.897004295 0.0 -16.395003 290.428019051 0.0 -16.397503 289.560634612 0.0 -16.400003 290.761373812 0.0 -16.402503 278.965088343 0.0 -16.405003 267.31352642 0.0 -16.407503 274.101624886 0.0 -16.410003 269.610171451 0.0 -16.412503 267.883891502 0.0 -16.415003 262.358201607 0.0 -16.417503 259.48473808 0.0 -16.420003 261.361437835 0.0 -16.422503 252.112712403 0.0 -16.425003 248.45809542 0.0 -16.427503 248.293037677 0.0 -16.430003 249.176970648 0.0 -16.432503 252.040482726 0.0 -16.435003 243.273487863 0.0 -16.437503 243.929413057 0.0 -16.440003 248.190294077 0.0 -16.442503 244.284785217 0.0 -16.445003 245.757367222 0.0 -16.447503 248.095056857 0.0 -16.450003 250.902053313 0.0 -16.452503 247.991578939 0.0 -16.455003 239.059082486 0.0 -16.457503 244.57101909 0.0 -16.460003 240.393682738 0.0 -16.462503 242.68059344 0.0 -16.465003 236.17695062 0.0 -16.467503 244.122494993 0.0 -16.470003 240.801054489 0.0 -16.472503 233.507351227 0.0 -16.475003 231.975511461 0.0 -16.477503 218.800826271 0.0 -16.480003 231.763062864 0.0 -16.482503 230.060200099 0.0 -16.485003 226.356565954 0.0 -16.487503 222.833760966 0.0 -16.490003 226.657062145 0.0 -16.492503 226.257077613 0.0 -16.495003 225.394535758 0.0 -16.497503 233.105853904 0.0 -16.500003 225.275472457 0.0 -16.502503 229.306807931 0.0 -16.505003 224.467476938 0.0 -16.507503 221.819719749 0.0 -16.510003 227.526172757 0.0 -16.512503 233.401194455 0.0 -16.515003 228.556099039 0.0 -16.517503 222.095936636 0.0 -16.520003 218.944761103 0.0 -16.522503 212.387855721 0.0 -16.525003 212.213811117 0.0 -16.527503 205.839145356 0.0 -16.530003 205.418887999 0.0 -16.532503 206.788085081 0.0 -16.535003 207.62759139 0.0 -16.537503 200.455921658 0.0 -16.540003 208.667153276 0.0 -16.542503 198.718955807 0.0 -16.545003 196.348297155 0.0 -16.547503 193.295398713 0.0 -16.550003 195.541104088 0.0 -16.552503 195.269625281 0.0 -16.555003 188.372889747 0.0 -16.557503 189.226025002 0.0 -16.560003 192.492622628 0.0 -16.562503 187.285080624 0.0 -16.565003 183.431950696 0.0 -16.567503 186.292398054 0.0 -16.570003 177.772734623 0.0 -16.572503 175.825326937 0.0 -16.575003 172.747123308 0.0 -16.577503 170.55138854 0.0 -16.580003 169.92354386 0.0 -16.582503 170.934492448 0.0 -16.585003 168.594484664 0.0 -16.587503 164.984228874 0.0 -16.590003 160.801046946 0.0 -16.592503 163.571849792 0.0 -16.595003 158.531514633 0.0 -16.597503 157.745188529 0.0 -16.600003 153.167543259 0.0 -16.602503 154.40458304 0.0 -16.605003 147.089785096 0.0 -16.607503 144.418446103 0.0 -16.610003 138.793826168 0.0 -16.612503 139.170180102 0.0 -16.615003 131.272025433 0.0 -16.617503 133.03465058 0.0 -16.620003 125.524446859 0.0 -16.622503 122.76927569 0.0 -16.625003 132.813295813 0.0 -16.627503 111.299872099 0.0 -16.630003 106.741712932 0.0 -16.632503 107.382534119 0.0 -16.635003 105.02458009 0.0 -16.637503 102.646205876 0.0 -16.640003 101.188224498 0.0 -16.642503 101.025846044 0.0 -16.645003 98.0252783011 0.0 -16.647503 93.89076084 0.0 -16.650003 83.0757830867 0.0 -16.652503 83.5340377846 0.0 -16.655003 81.3727029871 0.0 -16.657503 79.3002543732 0.0 -16.660003 73.296286952 0.0 -16.662503 71.9004515545 0.0 -16.665003 68.0497087663 0.0 -16.667503 63.1690301839 0.0 -16.670003 60.4509723657 0.0 -16.672503 57.3967199305 0.0 -16.675003 55.1138931874 0.0 -16.677503 53.7669359466 0.0 -16.680003 45.2837318674 0.0 -16.682503 49.5563520192 0.0 -16.685003 44.6928039698 0.0 -16.687503 35.9278092191 0.0 -16.690003 41.9426602294 0.0 -16.692503 39.0426834787 0.0 -16.695003 30.8079971237 0.0 -16.697503 31.5349303396 0.0 -16.700003 24.7364070526 0.0 -16.702503 27.0924096791 0.0 -16.705003 18.8949835666 0.0 -16.707503 15.2827677122 0.0 -16.710003 14.1932314181 0.0 -16.712503 7.79333848716 0.0 -16.715003 3.85532277081 0.0 -16.717503 4.76599457384 0.0 -16.720003 -3.71161402664 0.0 -16.722503 1.35386714988 0.0 -16.725003 0.611669628825 0.0 -16.727503 -8.07837457937 0.0 -16.730003 -0.356592723183 0.0 -16.732503 -10.3437949226 0.0 -16.735003 -7.78923707552 0.0 -16.737503 -11.8861759778 0.0 -16.740003 -11.1287993685 0.0 -16.742503 -12.1465536159 0.0 -16.745003 0.0 0.0 -16.747503 0.0 0.0 -16.750003 0.0 0.0 -16.752503 0.0 0.0 -16.755003 0.0 0.0 -16.757503 0.0 0.0 -16.760003 0.0 0.0 -16.762503 0.0 0.0 -16.765003 0.0 0.0 -16.767503 0.0 0.0 -16.770003 0.0 0.0 -16.772503 0.0 0.0 -16.775003 0.0 0.0 -16.777503 0.0 0.0 -16.780003 0.0 0.0 -16.782503 0.0 0.0 -16.785003 0.0 0.0 -16.787503 0.0 0.0 -16.790003 0.0 0.0 -16.792503 0.0 0.0 -16.795003 0.0 0.0 -16.797503 0.0 0.0 -16.800003 0.0 0.0 -16.802503 0.0 0.0 -16.805003 0.0 0.0 -16.807503 0.0 0.0 -16.810003 0.0 0.0 -16.812503 0.0 0.0 -16.815003 0.0 0.0 -16.817503 0.0 0.0 -16.820003 0.0 0.0 -16.822503 0.0 0.0 -16.825003 0.0 0.0 -16.827503 0.0 0.0 -16.830003 0.0 0.0 -16.832503 0.0 0.0 -16.835003 0.0 0.0 -16.837503 0.0 0.0 -16.840003 0.0 0.0 -16.842503 0.0 0.0 -16.845003 0.0 0.0 -16.847503 0.0 0.0 -16.850003 0.0 0.0 -16.852503 0.0 0.0 -16.855003 0.0 0.0 -16.857503 0.0 0.0 -16.860003 0.0 0.0 -16.862503 0.0 0.0 -16.865003 0.0 0.0 -16.867503 0.0 0.0 -16.870003 0.0 0.0 -16.872503 0.0 0.0 -16.875003 0.0 0.0 -16.877503 0.0 0.0 -16.880003 0.0 0.0 -16.882503 0.0 0.0 -16.885003 0.0 0.0 -16.887503 0.0 0.0 -16.890003 0.0 0.0 -16.892503 0.0 0.0 -16.895003 0.0 0.0 -16.897503 0.0 0.0 -16.900003 0.0 0.0 -16.902503 0.0 0.0 -16.905003 0.0 0.0 -16.907503 0.0 0.0 -16.910003 0.0 0.0 -16.912503 0.0 0.0 -16.915003 0.0 0.0 -16.917503 0.0 0.0 -16.920003 0.0 0.0 -16.922503 0.0 0.0 -16.925003 0.0 0.0 -16.927503 0.0 0.0 -16.930003 0.0 0.0 -16.932503 0.0 0.0 -16.935003 0.0 0.0 -16.937503 0.0 0.0 -16.940003 0.0 0.0 -16.942503 0.0 0.0 -16.945003 0.0 0.0 -16.947503 0.0 0.0 -16.950003 0.0 0.0 -16.952503 0.0 0.0 -16.955003 0.0 0.0 -16.957503 0.0 0.0 -16.960003 0.0 0.0 -16.962503 0.0 0.0 -16.965003 0.0 0.0 -16.967503 0.0 0.0 -16.970003 0.0 0.0 -16.972503 0.0 0.0 -16.975003 0.0 0.0 -16.977503 0.0 0.0 -16.980003 0.0 0.0 -16.982503 0.0 0.0 -16.985003 0.0 0.0 -16.987503 0.0 0.0 -16.990003 0.0 0.0 -16.992503 0.0 0.0 -16.995003 0.0 0.0 -16.997503 0.0 0.0 -17.000003 0.0 0.0 -17.002503 0.0 0.0 -17.005003 0.0 0.0 -17.007503 0.0 0.0 -17.010003 0.0 0.0 -17.012503 0.0 0.0 -17.015003 0.0 0.0 -17.017503 0.0 0.0 -17.020003 0.0 0.0 -17.022503 0.0 0.0 -17.025003 0.0 0.0 -17.027503 0.0 0.0 -17.030003 0.0 0.0 -17.032503 0.0 0.0 -17.035003 0.0 0.0 -17.037503 0.0 0.0 -17.040003 0.0 0.0 -17.042503 0.0 0.0 -17.045003 0.0 0.0 -17.047503 0.0 0.0 -17.050003 0.0 0.0 -17.052503 0.0 0.0 -17.055003 0.0 0.0 -17.057503 0.0 0.0 -17.060003 0.0 0.0 -17.062503 0.0 0.0 -17.065003 0.0 0.0 -17.067503 0.0 0.0 -17.070003 0.0 0.0 -17.072503 0.0 0.0 -17.075003 0.0 0.0 -17.077503 0.0 0.0 -17.080003 0.0 0.0 -17.082503 0.0 0.0 -17.085003 0.0 0.0 -17.087503 0.0 0.0 -17.090003 0.0 0.0 -17.092503 0.0 0.0 -17.095003 0.0 0.0 -17.097503 0.0 0.0 -17.100003 0.0 0.0 -17.102503 0.0 0.0 -17.105003 0.0 0.0 -17.107503 0.0 0.0 -17.110003 0.0 0.0 -17.112503 0.0 0.0 -17.115003 0.0 0.0 -17.117503 0.0 0.0 -17.120003 0.0 0.0 -17.122503 0.0 0.0 -17.125003 0.0 0.0 -17.127503 0.0 0.0 -17.130003 0.0 0.0 -17.132503 0.0 0.0 -17.135003 0.0 0.0 -17.137503 0.0 0.0 -17.140003 0.0 0.0 -17.142503 0.0 0.0 -17.145003 0.0 0.0 -17.147503 0.0 0.0 -17.150003 0.0 0.0 -17.152503 0.0 0.0 -17.155003 0.0 0.0 -17.157503 0.0 0.0 -17.160003 0.0 0.0 -17.162503 0.0 0.0 -17.165003 0.0 0.0 -17.167503 0.0 0.0 -17.170003 0.0 0.0 -17.172503 0.0 0.0 -17.175003 0.0 0.0 -17.177503 0.0 0.0 -17.180003 0.0 0.0 -17.182503 0.0 0.0 -17.185003 0.0 0.0 -17.187503 0.0 0.0 -17.190003 0.0 0.0 -17.192503 0.0 0.0 -17.195003 0.0 0.0 -17.197503 0.0 0.0 -17.200003 0.0 0.0 -17.202503 0.0 0.0 -17.205003 0.0 0.0 -17.207503 0.0 0.0 -17.210003 0.0 0.0 -17.212503 0.0 0.0 -17.215003 0.0 0.0 -17.217503 0.0 0.0 -17.220003 0.0 0.0 -17.222503 0.0 0.0 -17.225003 0.0 0.0 -17.227503 0.0 0.0 -17.230003 0.0 0.0 -17.232503 0.0 0.0 -17.235003 0.0 0.0 -17.237503 0.0 0.0 -17.240003 0.0 0.0 -17.242503 0.0 0.0 -17.245003 0.0 0.0 -17.247503 0.0 0.0 -17.250003 0.0 0.0 -17.252503 0.0 0.0 -17.255003 0.0 0.0 -17.257503 0.0 0.0 -17.260003 0.0 0.0 -17.262503 0.0 0.0 -17.265003 0.0 0.0 -17.267503 0.0 0.0 -17.270003 0.0 0.0 -17.272503 0.0 0.0 -17.275003 0.0 0.0 -17.277503 0.0 0.0 -17.280003 0.0 0.0 -17.282503 0.0 0.0 -17.285003 0.0 0.0 -17.287503 0.0 0.0 -17.290003 0.0 0.0 -17.292503 0.0 0.0 -17.295003 0.0 0.0 -17.297503 0.0 0.0 -17.300003 0.0 0.0 -17.302503 0.0 0.0 -17.305003 0.0 0.0 -17.307503 0.0 0.0 -17.310003 0.0 0.0 -17.312503 0.0 0.0 -17.315003 0.0 0.0 -17.317503 0.0 0.0 -17.320003 0.0 0.0 -17.322503 0.0 0.0 -17.325003 0.0 0.0 -17.327503 0.0 0.0 -17.330003 0.0 0.0 -17.332503 0.0 0.0 -17.335003 0.0 0.0 -17.337503 0.0 0.0 -17.340003 0.0 0.0 -17.342503 0.0 0.0 -17.345003 0.0 0.0 -17.347503 0.0 0.0 -17.350003 0.0 0.0 -17.352503 0.0 0.0 -17.355003 0.0 0.0 -17.357503 0.0 0.0 -17.360003 0.0 0.0 -17.362503 0.0 0.0 -17.365003 0.0 0.0 -17.367503 0.0 0.0 -17.370003 0.0 0.0 -17.372503 0.0 0.0 -17.375003 0.0 0.0 -17.377503 0.0 0.0 -17.380003 0.0 0.0 -17.382503 0.0 0.0 -17.385003 0.0 0.0 -17.387503 0.0 0.0 -17.390003 0.0 0.0 -17.392503 0.0 0.0 -17.395003 0.0 0.0 -17.397503 0.0 0.0 -17.400003 0.0 0.0 -17.402503 0.0 0.0 -17.405003 0.0 0.0 -17.407503 0.0 0.0 -17.410003 0.0 0.0 -17.412503 0.0 0.0 -17.415003 0.0 0.0 -17.417503 0.0 0.0 -17.420003 0.0 0.0 -17.422503 0.0 0.0 -17.425003 0.0 0.0 -17.427503 0.0 0.0 -17.430003 0.0 0.0 -17.432503 0.0 0.0 -17.435003 0.0 0.0 -17.437503 0.0 0.0 -17.440003 0.0 0.0 -17.442503 0.0 0.0 -17.445003 0.0 0.0 -17.447503 0.0 0.0 -17.450003 0.0 0.0 -17.452503 0.0 0.0 -17.455003 0.0 0.0 -17.457503 0.0 0.0 -17.460003 0.0 0.0 -17.462503 0.0 0.0 -17.465003 0.0 0.0 -17.467503 0.0 0.0 -17.470003 0.0 0.0 -17.472503 0.0 0.0 -17.475003 0.0 0.0 -17.477503 0.0 0.0 -17.480003 0.0 0.0 -17.482503 0.0 0.0 -17.485003 0.0 0.0 -17.487503 0.0 0.0 -17.490003 0.0 0.0 -17.492503 0.0 0.0 -17.495003 0.0 0.0 -17.497503 0.0 0.0 -17.500003 0.0 0.0 -17.502503 0.0 0.0 -17.505003 0.0 0.0 -17.507503 0.0 0.0 -17.510003 0.0 0.0 -17.512503 0.0 0.0 -17.515003 0.0 0.0 -17.517503 0.0 0.0 -17.520003 0.0 0.0 -17.522503 0.0 0.0 -17.525003 0.0 0.0 -17.527503 0.0 0.0 -17.530003 0.0 0.0 -17.532503 0.0 0.0 -17.535003 0.0 0.0 -17.537503 0.0 0.0 -17.540003 0.0 0.0 -17.542503 0.0 0.0 -17.545003 0.0 0.0 -17.547503 0.0 0.0 -17.550003 0.0 0.0 -17.552503 0.0 0.0 -17.555003 0.0 0.0 -17.557503 0.0 0.0 -17.560003 0.0 0.0 -17.562503 0.0 0.0 -17.565003 0.0 0.0 -17.567503 0.0 0.0 -17.570003 0.0 0.0 -17.572503 0.0 0.0 -17.575003 0.0 0.0 -17.577503 0.0 0.0 -17.580003 0.0 0.0 -17.582503 0.0 0.0 -17.585003 0.0 0.0 -17.587503 0.0 0.0 -17.590003 0.0 0.0 -17.592503 0.0 0.0 -17.595003 0.0 0.0 -17.597503 0.0 0.0 -17.600003 0.0 0.0 -17.602503 0.0 0.0 -17.605003 0.0 0.0 -17.607503 0.0 0.0 -17.610003 0.0 0.0 -17.612503 0.0 0.0 -17.615003 0.0 0.0 -17.617503 0.0 0.0 -17.620003 0.0 0.0 -17.622503 0.0 0.0 -17.625003 0.0 0.0 -17.627503 0.0 0.0 -17.630003 0.0 0.0 -17.632503 0.0 0.0 -17.635003 0.0 0.0 -17.637503 0.0 0.0 -17.640003 0.0 0.0 -17.642503 0.0 0.0 -17.645003 0.0 0.0 -17.647503 0.0 0.0 -17.650003 0.0 0.0 -17.652503 0.0 0.0 -17.655003 0.0 0.0 -17.657503 -123.824409844 0.0 -17.660003 173.262169434 0.0 -17.662503 620.510378855 0.0 -17.665003 620.510378855 0.0 -17.667503 620.510378855 0.0 -17.670003 773.165976192 0.0 -17.672503 1123.07599623 0.0 -17.675003 1429.19857348 0.0 -17.677503 1581.1589952 0.0 -17.680003 1423.58423053 0.0 -17.682503 1242.20197967 0.0 -17.685003 934.421008104 0.0 -17.687503 687.885274108 0.0 -17.690003 488.918779593 0.0 -17.692503 437.786602245 0.0 -17.695003 476.979826288 0.0 -17.697503 548.179528416 0.0 -17.700003 707.492066453 0.0 -17.702503 912.510787829 0.0 -17.705003 1104.27851512 0.0 -17.707503 1228.86448144 0.0 -17.710003 1252.87537977 0.0 -17.712503 1220.02714517 0.0 -17.715003 1174.97289033 0.0 -17.717503 1153.35910444 0.0 -17.720003 1120.22744364 0.0 -17.722503 1102.98126384 0.0 -17.725003 1052.21994872 0.0 -17.727503 1011.19058471 0.0 -17.730003 966.528172957 0.0 -17.732503 906.815121273 0.0 -17.735003 827.166461772 0.0 -17.737503 770.271917777 0.0 -17.740003 712.481029387 0.0 -17.742503 649.298464262 0.0 -17.745003 578.42789856 0.0 -17.747503 579.136794739 0.0 -17.750003 544.673065174 0.0 -17.752503 510.3846165 0.0 -17.755003 509.611931871 0.0 -17.757503 505.052296418 0.0 -17.760003 497.984128745 0.0 -17.762503 483.262414499 0.0 -17.765003 479.106610698 0.0 -17.767503 458.410755869 0.0 -17.770003 465.076121315 0.0 -17.772503 455.644648347 0.0 -17.775003 449.991294405 0.0 -17.777503 447.784003302 0.0 -17.780003 449.027331633 0.0 -17.782503 451.985305917 0.0 -17.785003 451.894606705 0.0 -17.787503 464.015132206 0.0 -17.790003 460.6308445 0.0 -17.792503 464.685625503 0.0 -17.795003 463.781191361 0.0 -17.797503 466.069289577 0.0 -17.800003 460.857061809 0.0 -17.802503 466.50955458 0.0 -17.805003 462.261300225 0.0 -17.807503 456.930418521 0.0 -17.810003 456.485066562 0.0 -17.812503 450.160951475 0.0 -17.815003 446.515958395 0.0 -17.817503 438.97594787 0.0 -17.820003 433.485093973 0.0 -17.822503 427.051804828 0.0 -17.825003 421.688660152 0.0 -17.827503 416.584603105 0.0 -17.830003 418.02993674 0.0 -17.832503 414.778749354 0.0 -17.835003 420.22017878 0.0 -17.837503 417.829775282 0.0 -17.840003 418.724750512 0.0 -17.842503 428.459160745 0.0 -17.845003 426.804926903 0.0 -17.847503 433.867109498 0.0 -17.850003 432.013980181 0.0 -17.852503 432.571372931 0.0 -17.855003 431.14171389 0.0 -17.857503 434.580685867 0.0 -17.860003 432.595399055 0.0 -17.862503 430.747165862 0.0 -17.865003 430.396288062 0.0 -17.867503 430.11691483 0.0 -17.870003 431.90339981 0.0 -17.872503 435.201186149 0.0 -17.875003 441.06223912 0.0 -17.877503 440.739614421 0.0 -17.880003 441.969484657 0.0 -17.882503 446.021979127 0.0 -17.885003 448.512002591 0.0 -17.887503 451.602274287 0.0 -17.890003 456.906949773 0.0 -17.892503 453.453349901 0.0 -17.895003 456.007132857 0.0 -17.897503 453.796271837 0.0 -17.900003 454.70446502 0.0 -17.902503 457.58155307 0.0 -17.905003 458.379176169 0.0 -17.907503 467.640638279 0.0 -17.910003 466.287639838 0.0 -17.912503 476.263718967 0.0 -17.915003 482.543488215 0.0 -17.917503 486.888639344 0.0 -17.920003 490.745820209 0.0 -17.922503 495.733518787 0.0 -17.925003 501.143601365 0.0 -17.927503 507.882592634 0.0 -17.930003 510.229049778 0.0 -17.932503 519.539232478 0.0 -17.935003 524.528358358 0.0 -17.937503 543.204978246 0.0 -17.940003 532.567962825 0.0 -17.942503 543.517350836 0.0 -17.945003 540.697941307 0.0 -17.947503 551.243403157 0.0 -17.950003 556.792827588 0.0 -17.952503 558.913139059 0.0 -17.955003 579.45855959 0.0 -17.957503 584.675443339 0.0 -17.960003 592.859384275 0.0 -17.962503 605.089425449 0.0 -17.965003 620.225094814 0.0 -17.967503 622.06447637 0.0 -17.970003 623.296238332 0.0 -17.972503 623.936184664 0.0 -17.975003 632.720244024 0.0 -17.977503 646.764246356 0.0 -17.980003 662.837233891 0.0 -17.982503 666.651883442 0.0 -17.985003 673.564749492 0.0 -17.987503 682.503623029 0.0 -17.990003 706.709846365 0.0 -17.992503 702.20788143 0.0 -17.995003 698.153379288 0.0 -17.997503 708.424965427 0.0 -18.000003 715.741064207 0.0 -18.002503 727.92270858 0.0 -18.005003 735.713359232 0.0 -18.007503 754.299357597 0.0 -18.010003 777.739467055 0.0 -18.012503 774.946174661 0.0 -18.015003 788.844311397 0.0 -18.017503 794.765362408 0.0 -18.020003 807.197204659 0.0 -18.022503 821.429637155 0.0 -18.025003 827.657795541 0.0 -18.027503 833.393350466 0.0 -18.030003 847.81817983 0.0 -18.032503 877.398207746 0.0 -18.035003 868.186277465 0.0 -18.037503 857.158891607 0.0 -18.040003 865.534651451 0.0 -18.042503 843.649138794 0.0 -18.045003 838.309155586 0.0 -18.047503 842.368810052 0.0 -18.050003 848.97780095 0.0 -18.052503 862.63257156 0.0 -18.055003 864.108671106 0.0 -18.057503 869.221276512 0.0 -18.060003 875.484441383 0.0 -18.062503 870.580086079 0.0 -18.065003 868.015576902 0.0 -18.067503 876.208095415 0.0 -18.070003 852.735306638 0.0 -18.072503 803.305338011 0.0 -18.075003 800.157412952 0.0 -18.077503 761.006470703 0.0 -18.080003 763.919518296 0.0 -18.082503 743.501110623 0.0 -18.085003 703.297293806 0.0 -18.087503 690.923724222 0.0 -18.090003 661.087557978 0.0 -18.092503 650.759328164 0.0 -18.095003 621.883345709 0.0 -18.097503 606.176699178 0.0 -18.100003 592.135048189 0.0 -18.102503 573.952695573 0.0 -18.105003 553.582072373 0.0 -18.107503 551.917299825 0.0 -18.110003 568.811264266 0.0 -18.112503 594.534928628 0.0 -18.115003 571.813919087 0.0 -18.117503 588.345962829 0.0 -18.120003 592.863235582 0.0 -18.122503 620.3455348 0.0 -18.125003 615.432439413 0.0 -18.127503 595.88362888 0.0 -18.130003 576.709656358 0.0 -18.132503 555.331717975 0.0 -18.135003 535.379834664 0.0 -18.137503 501.594231364 0.0 -18.140003 476.721016933 0.0 -18.142503 444.577242468 0.0 -18.145003 407.859314857 0.0 -18.147503 386.125111407 0.0 -18.150003 358.069683357 0.0 -18.152503 341.366996239 0.0 -18.155003 322.749177778 0.0 -18.157503 312.955015924 0.0 -18.160003 301.538595633 0.0 -18.162503 293.873530839 0.0 -18.165003 289.077575197 0.0 -18.167503 288.400387653 0.0 -18.170003 293.885988326 0.0 -18.172503 301.609787849 0.0 -18.175003 298.857371108 0.0 -18.177503 297.633026496 0.0 -18.180003 302.000574245 0.0 -18.182503 303.150738443 0.0 -18.185003 302.202694143 0.0 -18.187503 301.976709843 0.0 -18.190003 291.566714372 0.0 -18.192503 282.596058151 0.0 -18.195003 273.98186214 0.0 -18.197503 272.953894586 0.0 -18.200003 262.91376753 0.0 -18.202503 251.564933406 0.0 -18.205003 242.470397539 0.0 -18.207503 237.939949825 0.0 -18.210003 243.283441832 0.0 -18.212503 259.979479172 0.0 -18.215003 263.579117561 0.0 -18.217503 269.695998599 0.0 -18.220003 277.09031652 0.0 -18.222503 286.744326703 0.0 -18.225003 308.167075716 0.0 -18.227503 306.465066291 0.0 -18.230003 306.696135236 0.0 -18.232503 311.43687114 0.0 -18.235003 315.431849602 0.0 -18.237503 318.366457243 0.0 -18.240003 312.122118682 0.0 -18.242503 299.553435776 0.0 -18.245003 296.418815767 0.0 -18.247503 288.970466304 0.0 -18.250003 282.23199571 0.0 -18.252503 278.361702053 0.0 -18.255003 269.414747019 0.0 -18.257503 266.317559711 0.0 -18.260003 260.625048778 0.0 -18.262503 256.970910688 0.0 -18.265003 254.062903731 0.0 -18.267503 250.520558615 0.0 -18.270003 257.4661249 0.0 -18.272503 264.439755347 0.0 -18.275003 259.264780736 0.0 -18.277503 260.05778606 0.0 -18.280003 259.021133655 0.0 -18.282503 259.4029282 0.0 -18.285003 264.025127193 0.0 -18.287503 268.884195923 0.0 -18.290003 273.594458563 0.0 -18.292503 271.186719884 0.0 -18.295003 274.775413039 0.0 -18.297503 279.645074353 0.0 -18.300003 281.283713749 0.0 -18.302503 282.73167257 0.0 -18.305003 305.05218543 0.0 -18.307503 304.626786589 0.0 -18.310003 298.721151323 0.0 -18.312503 279.090484159 0.0 -18.315003 283.643763091 0.0 -18.317503 290.323063153 0.0 -18.320003 298.546343409 0.0 -18.322503 307.193407656 0.0 -18.325003 310.655567692 0.0 -18.327503 321.845816168 0.0 -18.330003 324.247926981 0.0 -18.332503 329.220186479 0.0 -18.335003 327.895716643 0.0 -18.337503 326.725041661 0.0 -18.340003 347.704616815 0.0 -18.342503 363.66921235 0.0 -18.345003 349.90713663 0.0 -18.347503 342.907383324 0.0 -18.350003 343.33986015 0.0 -18.352503 334.767418883 0.0 -18.355003 326.888043666 0.0 -18.357503 324.899249483 0.0 -18.360003 315.017512641 0.0 -18.362503 305.844653681 0.0 -18.365003 299.074002045 0.0 -18.367503 294.451679836 0.0 -18.370003 288.745054001 0.0 -18.372503 290.10336278 0.0 -18.375003 295.108868177 0.0 -18.377503 290.715399437 0.0 -18.380003 289.492444076 0.0 -18.382503 286.921238805 0.0 -18.385003 282.392289267 0.0 -18.387503 290.012960813 0.0 -18.390003 288.831237496 0.0 -18.392503 286.216068739 0.0 -18.395003 292.152105713 0.0 -18.397503 291.695167889 0.0 -18.400003 285.581047556 0.0 -18.402503 292.967915184 0.0 -18.405003 284.816739701 0.0 -18.407503 291.59807413 0.0 -18.410003 289.474461017 0.0 -18.412503 290.15166018 0.0 -18.415003 281.861206187 0.0 -18.417503 281.194084074 0.0 -18.420003 278.635222905 0.0 -18.422503 277.998561484 0.0 -18.425003 270.702231843 0.0 -18.427503 264.290760474 0.0 -18.430003 265.098823278 0.0 -18.432503 263.922895054 0.0 -18.435003 257.152456279 0.0 -18.437503 256.834668988 0.0 -18.440003 251.793872441 0.0 -18.442503 250.333458979 0.0 -18.445003 249.79392594 0.0 -18.447503 251.10519971 0.0 -18.450003 244.289593395 0.0 -18.452503 246.142130479 0.0 -18.455003 243.833960734 0.0 -18.457503 242.131448711 0.0 -18.460003 241.808460229 0.0 -18.462503 241.532518688 0.0 -18.465003 237.972298737 0.0 -18.467503 239.262280203 0.0 -18.470003 238.066869563 0.0 -18.472503 236.334929118 0.0 -18.475003 238.138019135 0.0 -18.477503 234.264898666 0.0 -18.480003 232.737210757 0.0 -18.482503 229.742855376 0.0 -18.485003 225.999219663 0.0 -18.487503 225.381514122 0.0 -18.490003 226.959514568 0.0 -18.492503 224.223719976 0.0 -18.495003 214.903419829 0.0 -18.497503 219.474814488 0.0 -18.500003 210.075660041 0.0 -18.502503 210.080936234 0.0 -18.505003 212.881315322 0.0 -18.507503 207.130686907 0.0 -18.510003 204.583948459 0.0 -18.512503 201.026314108 0.0 -18.515003 197.545028882 0.0 -18.517503 199.05612604 0.0 -18.520003 195.699827555 0.0 -18.522503 199.871074798 0.0 -18.525003 192.74548862 0.0 -18.527503 192.80624067 0.0 -18.530003 186.6511866 0.0 -18.532503 183.996853728 0.0 -18.535003 184.902609519 0.0 -18.537503 176.647954829 0.0 -18.540003 172.44250868 0.0 -18.542503 176.984636005 0.0 -18.545003 163.860835758 0.0 -18.547503 158.28462452 0.0 -18.550003 149.510304792 0.0 -18.552503 145.231829496 0.0 -18.555003 145.924568122 0.0 -18.557503 135.674935358 0.0 -18.560003 132.674343086 0.0 -18.562503 122.410344585 0.0 -18.565003 113.780872501 0.0 -18.567503 108.046924935 0.0 -18.570003 101.214556213 0.0 -18.572503 98.9926469577 0.0 -18.575003 87.2269115107 0.0 -18.577503 79.1659655808 0.0 -18.580003 77.4011463399 0.0 -18.582503 69.23389685 0.0 -18.585003 57.604938477 0.0 -18.587503 48.922022151 0.0 -18.590003 44.0019151931 0.0 -18.592503 29.0969364881 0.0 -18.595003 26.1023382568 0.0 -18.597503 14.6286005504 0.0 -18.600003 10.4986029084 0.0 -18.602503 -0.132362859409 0.0 -18.605003 -8.15351247745 0.0 -18.607503 -4.80736432586 0.0 -18.610003 -14.4045045053 0.0 -18.612503 -20.9493298747 0.0 -18.615003 -26.6961641452 0.0 -18.617503 0.0 0.0 -18.620003 0.0 0.0 -18.622503 0.0 0.0 -18.625003 0.0 0.0 -18.627503 0.0 0.0 -18.630003 0.0 0.0 -18.632503 0.0 0.0 -18.635003 0.0 0.0 -18.637503 0.0 0.0 -18.640003 0.0 0.0 -18.642503 0.0 0.0 -18.645003 0.0 0.0 -18.647503 0.0 0.0 -18.650003 0.0 0.0 -18.652503 0.0 0.0 -18.655003 0.0 0.0 -18.657503 0.0 0.0 -18.660003 0.0 0.0 -18.662503 0.0 0.0 -18.665003 0.0 0.0 -18.667503 0.0 0.0 -18.670003 0.0 0.0 -18.672503 0.0 0.0 -18.675003 0.0 0.0 -18.677503 0.0 0.0 -18.680003 0.0 0.0 -18.682503 0.0 0.0 -18.685003 0.0 0.0 -18.687503 0.0 0.0 -18.690003 0.0 0.0 -18.692503 0.0 0.0 -18.695003 0.0 0.0 -18.697503 0.0 0.0 -18.700003 0.0 0.0 -18.702503 0.0 0.0 -18.705003 0.0 0.0 -18.707503 0.0 0.0 -18.710003 0.0 0.0 -18.712503 0.0 0.0 -18.715003 0.0 0.0 -18.717503 0.0 0.0 -18.720003 0.0 0.0 -18.722503 0.0 0.0 -18.725003 0.0 0.0 -18.727503 0.0 0.0 -18.730003 0.0 0.0 -18.732503 0.0 0.0 -18.735003 0.0 0.0 -18.737503 0.0 0.0 -18.740003 0.0 0.0 -18.742503 0.0 0.0 -18.745003 0.0 0.0 -18.747503 0.0 0.0 -18.750003 0.0 0.0 -18.752503 0.0 0.0 -18.755003 0.0 0.0 -18.757503 0.0 0.0 -18.760003 0.0 0.0 -18.762503 0.0 0.0 -18.765003 0.0 0.0 -18.767503 0.0 0.0 -18.770003 0.0 0.0 -18.772503 0.0 0.0 -18.775003 0.0 0.0 -18.777503 0.0 0.0 -18.780003 0.0 0.0 -18.782503 0.0 0.0 -18.785003 0.0 0.0 -18.787503 0.0 0.0 -18.790003 0.0 0.0 -18.792503 0.0 0.0 -18.795003 0.0 0.0 -18.797503 0.0 0.0 -18.800003 0.0 0.0 -18.802503 0.0 0.0 -18.805003 0.0 0.0 -18.807503 0.0 0.0 -18.810003 0.0 0.0 -18.812503 0.0 0.0 -18.815003 0.0 0.0 -18.817503 0.0 0.0 -18.820003 0.0 0.0 -18.822503 0.0 0.0 -18.825003 0.0 0.0 -18.827503 0.0 0.0 -18.830003 0.0 0.0 -18.832503 0.0 0.0 -18.835003 0.0 0.0 -18.837503 0.0 0.0 -18.840003 0.0 0.0 -18.842503 0.0 0.0 -18.845003 0.0 0.0 -18.847503 0.0 0.0 -18.850003 0.0 0.0 -18.852503 0.0 0.0 -18.855003 0.0 0.0 -18.857503 0.0 0.0 -18.860003 0.0 0.0 -18.862503 0.0 0.0 -18.865003 0.0 0.0 -18.867503 0.0 0.0 -18.870003 0.0 0.0 -18.872503 0.0 0.0 -18.875003 0.0 0.0 -18.877503 0.0 0.0 -18.880003 0.0 0.0 -18.882503 0.0 0.0 -18.885003 0.0 0.0 -18.887503 0.0 0.0 -18.890003 0.0 0.0 -18.892503 0.0 0.0 -18.895003 0.0 0.0 -18.897503 0.0 0.0 -18.900003 0.0 0.0 -18.902503 0.0 0.0 -18.905003 0.0 0.0 -18.907503 0.0 0.0 -18.910003 0.0 0.0 -18.912503 0.0 0.0 -18.915003 0.0 0.0 -18.917503 0.0 0.0 -18.920003 0.0 0.0 -18.922503 0.0 0.0 -18.925003 0.0 0.0 -18.927503 0.0 0.0 -18.930003 0.0 0.0 -18.932503 0.0 0.0 -18.935003 0.0 0.0 -18.937503 0.0 0.0 -18.940003 0.0 0.0 -18.942503 0.0 0.0 -18.945003 0.0 0.0 -18.947503 0.0 0.0 -18.950003 0.0 0.0 -18.952503 0.0 0.0 -18.955003 0.0 0.0 -18.957503 0.0 0.0 -18.960003 0.0 0.0 -18.962503 0.0 0.0 -18.965003 0.0 0.0 -18.967503 0.0 0.0 -18.970003 0.0 0.0 -18.972503 0.0 0.0 -18.975003 0.0 0.0 -18.977503 0.0 0.0 -18.980003 0.0 0.0 -18.982503 0.0 0.0 -18.985003 0.0 0.0 -18.987503 0.0 0.0 -18.990003 0.0 0.0 -18.992503 0.0 0.0 -18.995003 0.0 0.0 -18.997503 0.0 0.0 -19.000003 0.0 0.0 -19.002503 0.0 0.0 -19.005003 0.0 0.0 -19.007503 0.0 0.0 -19.010003 0.0 0.0 -19.012503 0.0 0.0 -19.015003 0.0 0.0 -19.017503 0.0 0.0 -19.020003 0.0 0.0 -19.022503 0.0 0.0 -19.025003 0.0 0.0 -19.027503 0.0 0.0 -19.030003 0.0 0.0 -19.032503 0.0 0.0 -19.035003 0.0 0.0 -19.037503 0.0 0.0 -19.040003 0.0 0.0 -19.042503 0.0 0.0 -19.045003 0.0 0.0 -19.047503 0.0 0.0 -19.050003 0.0 0.0 -19.052503 0.0 0.0 -19.055003 0.0 0.0 -19.057503 0.0 0.0 -19.060003 0.0 0.0 -19.062503 0.0 0.0 -19.065003 0.0 0.0 -19.067503 0.0 0.0 -19.070003 0.0 0.0 -19.072503 0.0 0.0 -19.075003 0.0 0.0 -19.077503 0.0 0.0 -19.080003 0.0 0.0 -19.082503 0.0 0.0 -19.085003 0.0 0.0 -19.087503 0.0 0.0 -19.090003 0.0 0.0 -19.092503 0.0 0.0 -19.095003 0.0 0.0 -19.097503 0.0 0.0 -19.100003 0.0 0.0 -19.102503 0.0 0.0 -19.105003 0.0 0.0 -19.107503 0.0 0.0 -19.110003 0.0 0.0 -19.112503 0.0 0.0 -19.115003 0.0 0.0 -19.117503 0.0 0.0 -19.120003 0.0 0.0 -19.122503 0.0 0.0 -19.125003 0.0 0.0 -19.127503 0.0 0.0 -19.130003 0.0 0.0 -19.132503 0.0 0.0 -19.135003 0.0 0.0 -19.137503 0.0 0.0 -19.140003 0.0 0.0 -19.142503 0.0 0.0 -19.145003 0.0 0.0 -19.147503 0.0 0.0 -19.150003 0.0 0.0 -19.152503 0.0 0.0 -19.155003 0.0 0.0 -19.157503 0.0 0.0 -19.160003 0.0 0.0 -19.162503 0.0 0.0 -19.165003 0.0 0.0 -19.167503 0.0 0.0 -19.170003 0.0 0.0 -19.172503 0.0 0.0 -19.175003 0.0 0.0 -19.177503 0.0 0.0 -19.180003 0.0 0.0 -19.182503 0.0 0.0 -19.185003 0.0 0.0 -19.187503 0.0 0.0 -19.190003 0.0 0.0 -19.192503 0.0 0.0 -19.195003 0.0 0.0 -19.197503 0.0 0.0 -19.200003 0.0 0.0 -19.202503 0.0 0.0 -19.205003 0.0 0.0 -19.207503 0.0 0.0 -19.210003 0.0 0.0 -19.212503 0.0 0.0 -19.215003 0.0 0.0 -19.217503 0.0 0.0 -19.220003 0.0 0.0 -19.222503 0.0 0.0 -19.225003 0.0 0.0 -19.227503 0.0 0.0 -19.230003 0.0 0.0 -19.232503 0.0 0.0 -19.235003 0.0 0.0 -19.237503 0.0 0.0 -19.240003 0.0 0.0 -19.242503 0.0 0.0 -19.245003 0.0 0.0 -19.247503 0.0 0.0 -19.250003 0.0 0.0 -19.252503 0.0 0.0 -19.255003 0.0 0.0 -19.257503 0.0 0.0 -19.260003 0.0 0.0 -19.262503 0.0 0.0 -19.265003 0.0 0.0 -19.267503 0.0 0.0 -19.270003 0.0 0.0 -19.272503 0.0 0.0 -19.275003 0.0 0.0 -19.277503 0.0 0.0 -19.280003 0.0 0.0 -19.282503 0.0 0.0 -19.285003 0.0 0.0 -19.287503 0.0 0.0 -19.290003 0.0 0.0 -19.292503 0.0 0.0 -19.295003 0.0 0.0 -19.297503 0.0 0.0 -19.300003 0.0 0.0 -19.302503 0.0 0.0 -19.305003 0.0 0.0 -19.307503 0.0 0.0 -19.310003 0.0 0.0 -19.312503 0.0 0.0 -19.315003 0.0 0.0 -19.317503 0.0 0.0 -19.320003 0.0 0.0 -19.322503 0.0 0.0 -19.325003 0.0 0.0 -19.327503 0.0 0.0 -19.330003 0.0 0.0 -19.332503 0.0 0.0 -19.335003 0.0 0.0 -19.337503 0.0 0.0 -19.340003 0.0 0.0 -19.342503 0.0 0.0 -19.345003 0.0 0.0 -19.347503 0.0 0.0 -19.350003 0.0 0.0 -19.352503 0.0 0.0 -19.355003 0.0 0.0 -19.357503 0.0 0.0 -19.360003 0.0 0.0 -19.362503 0.0 0.0 -19.365003 0.0 0.0 -19.367503 0.0 0.0 -19.370003 0.0 0.0 -19.372503 0.0 0.0 -19.375003 0.0 0.0 -19.377503 0.0 0.0 -19.380003 0.0 0.0 -19.382503 0.0 0.0 -19.385003 0.0 0.0 -19.387503 0.0 0.0 -19.390003 0.0 0.0 -19.392503 0.0 0.0 -19.395003 0.0 0.0 -19.397503 0.0 0.0 -19.400003 0.0 0.0 -19.402503 0.0 0.0 -19.405003 0.0 0.0 -19.407503 0.0 0.0 -19.410003 0.0 0.0 -19.412503 0.0 0.0 -19.415003 0.0 0.0 -19.417503 0.0 0.0 -19.420003 0.0 0.0 -19.422503 0.0 0.0 -19.425003 0.0 0.0 -19.427503 0.0 0.0 -19.430003 0.0 0.0 -19.432503 0.0 0.0 -19.435003 0.0 0.0 -19.437503 0.0 0.0 -19.440003 0.0 0.0 -19.442503 0.0 0.0 -19.445003 0.0 0.0 -19.447503 0.0 0.0 -19.450003 0.0 0.0 -19.452503 0.0 0.0 -19.455003 0.0 0.0 -19.457503 0.0 0.0 -19.460003 0.0 0.0 -19.462503 0.0 0.0 -19.465003 0.0 0.0 -19.467503 0.0 0.0 -19.470003 0.0 0.0 -19.472503 0.0 0.0 -19.475003 0.0 0.0 -19.477503 0.0 0.0 -19.480003 0.0 0.0 -19.482503 0.0 0.0 -19.485003 0.0 0.0 -19.487503 0.0 0.0 -19.490003 0.0 0.0 -19.492503 0.0 0.0 -19.495003 0.0 0.0 -19.497503 0.0 0.0 -19.500003 0.0 0.0 -19.502503 0.0 0.0 -19.505003 0.0 0.0 -19.507503 0.0 0.0 -19.510003 0.0 0.0 -19.512503 0.0 0.0 -19.515003 0.0 0.0 -19.517503 0.0 0.0 -19.520003 0.0 0.0 -19.522503 0.0 0.0 -19.525003 0.0 0.0 -19.527503 0.0 0.0 -19.530003 0.0 0.0 -19.532503 0.0 0.0 -19.535003 0.0 0.0 -19.537503 0.0 0.0 -19.540003 0.0 0.0 -19.542503 0.0 0.0 -19.545003 0.0 0.0 -19.547503 0.0 0.0 -19.550003 0.0 0.0 -19.552503 0.0 0.0 -19.555003 0.0 0.0 -19.557503 405.44100795 0.0 -19.560003 78.1423473609 0.0 -19.562503 -58.0426497198 0.0 -19.565003 21.6668223143 0.0 -19.567503 -8.29274605863 0.0 -19.570003 -2.39017666159 0.0 -19.572503 -4.62743785428 0.0 -19.575003 -6.26245415176 0.0 -19.577503 242.038802295 0.0 -19.580003 486.943253885 0.0 -19.582503 765.229300071 0.0 -19.585003 1005.17081365 0.0 -19.587503 1297.92489833 0.0 -19.590003 1515.92964266 0.0 -19.592503 1527.81634194 0.0 -19.595003 1530.0874033 0.0 -19.597503 1305.52678332 0.0 -19.600003 1030.83950585 0.0 -19.602503 788.526135882 0.0 -19.605003 745.40494566 0.0 -19.607503 653.315737393 0.0 -19.610003 691.176484665 0.0 -19.612503 846.296509294 0.0 -19.615003 1004.95875422 0.0 -19.617503 1206.20297015 0.0 -19.620003 1395.70897797 0.0 -19.622503 1516.28072062 0.0 -19.625003 1572.01912168 0.0 -19.627503 1592.18810746 0.0 -19.630003 1533.37984968 0.0 -19.632503 1439.64129228 0.0 -19.635003 1324.34102537 0.0 -19.637503 1181.27552792 0.0 -19.640003 1102.34107112 0.0 -19.642503 1026.84094033 0.0 -19.645003 952.119197978 0.0 -19.647503 904.369315261 0.0 -19.650003 894.073517154 0.0 -19.652503 860.283139207 0.0 -19.655003 845.603018406 0.0 -19.657503 830.074333754 0.0 -19.660003 816.794701577 0.0 -19.662503 801.86161018 0.0 -19.665003 793.953704743 0.0 -19.667503 785.632916288 0.0 -19.670003 756.598821402 0.0 -19.672503 732.456457502 0.0 -19.675003 702.314392136 0.0 -19.677503 674.250986185 0.0 -19.680003 645.951390336 0.0 -19.682503 618.241696679 0.0 -19.685003 590.676056623 0.0 -19.687503 564.669531122 0.0 -19.690003 535.057144295 0.0 -19.692503 513.369853505 0.0 -19.695003 493.93276484 0.0 -19.697503 481.569125767 0.0 -19.700003 476.767599609 0.0 -19.702503 466.221893165 0.0 -19.705003 454.074524169 0.0 -19.707503 447.652335948 0.0 -19.710003 443.077188154 0.0 -19.712503 441.409660942 0.0 -19.715003 439.303227618 0.0 -19.717503 437.213462332 0.0 -19.720003 434.489319254 0.0 -19.722503 429.724978989 0.0 -19.725003 428.727024889 0.0 -19.727503 425.86858389 0.0 -19.730003 424.948987832 0.0 -19.732503 422.282120986 0.0 -19.735003 419.103290322 1.41591162573 -19.737503 418.015000503 1.4092095954 -19.740003 417.808910388 1.42788224055 -19.742503 408.495414913 1.39980562808 -19.745003 401.147034665 0.0 -19.747503 397.646755914 0.0 -19.750003 392.895114125 0.0 -19.752503 394.519565871 2.47096019038 -19.755003 389.906062581 2.02447122815 -19.757503 392.308746236 1.81124214994 -19.760003 392.900560696 4.15265962132 -19.762503 389.428111711 0.0 -19.765003 387.696179053 9.25938267795 -19.767503 385.019810731 0.0 -19.770003 384.252198332 2.52363524568 -19.772503 388.800668697 3.26012122406 -19.775003 393.680867947 3.39260817835 -19.777503 396.608197274 5.15321320111 -19.780003 397.971828875 1.66590485641 -19.782503 402.710623814 38.1326030585 -19.785003 407.669240438 17.6696835062 -19.787503 407.476549135 -51.5856927592 -19.790003 408.265899964 2.08443074094 -19.792503 408.219225391 1.98317447318 -19.795003 412.766285323 10.0329761333 -19.797503 410.103185546 10.0702174331 -19.800003 413.232447666 2.42029994132 -19.802503 408.560653848 -16.0903087352 -19.805003 408.385579836 2.12781950922 -19.807503 416.627542917 2.10982826887 -19.810003 419.603230366 2.15316931442 -19.812503 422.030645779 2.18117336031 -19.815003 427.510050572 2.20255973643 -19.817503 429.566602386 2.19421195326 -19.820003 434.716247851 2.48084941536 -19.822503 434.432137407 2.52206242176 -19.825003 431.686235778 2.57047150474 -19.827503 457.545218287 0.0 -19.830003 447.330513282 0.0 -19.832503 448.634606972 6.44692646273 -19.835003 454.86914666 3.93972213395 -19.837503 456.041576806 8.58909194755 -19.840003 472.742143344 -4.9586065878 -19.842503 482.898499281 7.10639371496 -19.845003 476.026503466 -4.79244139719 -19.847503 483.518752054 7.02339392821 -19.850003 480.436450756 42.5034629904 -19.852503 494.315919694 16.366739781 -19.855003 502.192245314 9.08790406868 -19.857503 516.838373565 25.6450404241 -19.860003 527.273186952 -11.355986432 -19.862503 528.006670685 1.84875611075 -19.865003 539.0267095 4.16563238896 -19.867503 554.3558302 -1.70911229313 -19.870003 574.293601482 -1.02889440457 -19.872503 584.834190663 -9.07140286089 -19.875003 587.614944509 -0.97368407119 -19.877503 596.51393343 5.13757156167 -19.880003 616.246801009 21.3709755192 -19.882503 629.668701617 6.57585163594 -19.885003 646.246578972 7.02440375209 -19.887503 652.134286565 -10.6288696367 -19.890003 673.501938871 3.74339075137 -19.892503 686.550218236 1.12392846267 -19.895003 690.629969305 0.118518408114 -19.897503 698.275719875 4.44242091682 -19.900003 714.031414644 2.24890125073 -19.902503 720.887669304 0.0911392896093 -19.905003 738.147657709 -1.94002194819 -19.907503 752.87746033 0.0 -19.910003 765.758430774 0.0 -19.912503 769.417011454 0.0 -19.915003 772.388569106 0.0 -19.917503 779.864253122 0.0 -19.920003 790.5895129 0.0 -19.922503 783.166932532 0.0 -19.925003 790.882283917 0.0 -19.927503 793.472511233 0.0 -19.930003 811.150185134 0.0 -19.932503 807.229909944 0.0 -19.935003 820.153332007 0.0 -19.937503 864.679618962 0.0 -19.940003 879.033440295 0.0 -19.942503 894.827414026 0.0 -19.945003 900.315237872 0.0 -19.947503 920.165166331 0.0 -19.950003 930.579985705 0.0 -19.952503 944.892982731 0.0 -19.955003 977.218353406 0.0 -19.957503 971.660287991 0.0 -19.960003 966.794601533 0.0 -19.962503 992.524808303 0.0 -19.965003 1034.0646494 0.0 -19.967503 1043.55049663 0.0 -19.970003 1043.98646354 0.0 -19.972503 1035.65901755 0.0 -19.975003 1091.4239076 0.0 -19.977503 1114.48407769 0.0 -19.980003 1094.46254277 0.0 -19.982503 1092.23668643 0.0 -19.985003 1086.60167599 0.0 -19.987503 1031.49340067 0.0 -19.990003 989.691322477 0.0 -19.992503 957.892171363 0.0 -19.995003 910.518112242 0.0 -19.997503 899.499535859 0.0 -20.000003 861.238990466 0.0 diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history (copy).csv b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history (copy).csv deleted file mode 100644 index 5e6faaed6e4b..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history (copy).csv +++ /dev/null @@ -1,1041 +0,0 @@ -time (0.0,0.093) (0.0,0.299) -1e-06 0.0 0.0 -2e-06 0.0 0.0 -3e-06 0.0 0.0 -0.005003 0.0 0.0 -0.010003 0.0 0.0 -0.015003 -27.1059131187 0.0 -0.020003 25.3947360704 0.0 -0.025003 74.6142681332 0.0 -0.030003 94.31203834 0.0 -0.035003 98.105097412 0.0 -0.040003 100.23497559 0.0 -0.045003 104.05259294 0.0 -0.050003 109.185789712 0.0 -0.055003 114.065269444 0.0 -0.060003 117.870525251 0.0 -0.065003 120.119816695 0.0 -0.070003 121.705589186 0.0 -0.075003 123.747646501 0.0 -0.080003 123.747646501 0.0 -0.085003 119.994957118 0.0 -0.090003 120.713746033 0.0 -0.095003 124.989674111 0.0 -0.100003 131.000035635 0.0 -0.105003 139.155580907 0.0 -0.110003 148.474397355 0.0 -0.115003 158.617314957 0.0 -0.120003 168.398561747 0.0 -0.125003 176.667908959 0.0 -0.130003 184.173922906 0.0 -0.135003 188.290403207 0.0 -0.140003 199.075600101 0.0 -0.145003 212.825982141 0.0 -0.150003 225.607612871 0.0 -0.155003 237.259170705 0.0 -0.160003 247.610784269 0.0 -0.165003 256.236258304 0.0 -0.170003 263.82409683 0.0 -0.175003 270.51678393 0.0 -0.180003 276.556915826 0.0 -0.185003 276.556915826 0.0 -0.190003 272.843753326 0.0 -0.195003 273.179686792 0.0 -0.200003 276.410121983 0.0 -0.205003 280.499318869 0.0 -0.210003 285.327755941 0.0 -0.215003 290.721199588 0.0 -0.220003 296.031288735 0.0 -0.225003 301.061562041 0.0 -0.230003 305.417689852 0.0 -0.235003 308.600332073 0.0 -0.240003 311.314832049 0.0 -0.245003 315.012780365 0.0 -0.250003 318.652779391 0.0 -0.255003 318.652779391 0.0 -0.260003 321.254210148 0.0 -0.265003 321.250186226 0.0 -0.270003 322.889226727 0.0 -0.275003 325.488324949 0.0 -0.280003 329.819374169 0.0 -0.285003 335.377583751 0.0 -0.290003 341.301765557 0.0 -0.295003 347.678522786 0.0 -0.300003 356.530958408 0.0 -0.305003 367.349085686 0.0 -0.310003 377.779168088 0.0 -0.315003 388.822251578 0.0 -0.320003 399.045755953 0.0 -0.325003 407.857208114 0.0 -0.330003 415.374530549 0.0 -0.335003 422.518064765 0.0 -0.340003 428.593047327 0.0 -0.345003 433.964793744 0.0 -0.350003 438.453749803 0.0 -0.355003 443.374955048 0.0 -0.360003 448.300833054 0.0 -0.365003 452.989711439 0.0 -0.370003 457.753932642 0.0 -0.375003 462.072938929 0.0 -0.380003 466.292909562 0.0 -0.385003 470.735611344 0.0 -0.390003 474.753494491 0.0 -0.395003 474.753494491 0.0 -0.400003 474.67640149 0.0 -0.405003 476.740865551 0.0 -0.410003 479.712691014 0.0 -0.415003 484.508634457 0.0 -0.420003 489.126975172 0.0 -0.425003 493.207254297 0.0 -0.430003 496.650714539 0.0 -0.435003 499.862228713 0.0 -0.440003 503.035371604 0.0 -0.445003 506.208834195 0.0 -0.450003 508.914130677 0.0 -0.455003 511.457450876 0.0 -0.460003 514.012237677 0.0 -0.465003 516.392951612 0.0 -0.470003 518.356204096 0.0 -0.475003 520.957226093 0.0 -0.480003 523.332088822 0.0 -0.485003 525.259180055 0.0 -0.490003 527.026338518 0.0 -0.495003 528.426779359 0.0 -0.500003 530.042360358 0.0 -0.505003 530.509978353 0.0 -0.510003 531.093161654 0.0 -0.515003 532.147266406 0.0 -0.520003 533.109977413 0.0 -0.525003 534.5117784 0.0 -0.530003 535.534209974 0.0 -0.535003 536.684862096 0.0 -0.540003 537.43580801 0.0 -0.545003 538.72323129 0.0 -0.550003 539.360306182 0.0 -0.555003 539.965289837 0.0 -0.560003 540.161747684 0.0 -0.565003 540.68710233 0.0 -0.570003 541.267897299 0.0 -0.575003 541.379814679 0.0 -0.580003 541.379814679 0.0 -0.585003 539.759426814 0.0 -0.590003 536.665106434 0.0 -0.595003 534.245082668 0.0 -0.600003 532.366510168 0.0 -0.605003 525.438601935 0.0 -0.610003 527.166333178 0.0 -0.615003 527.941776381 0.0 -0.620003 529.425682453 0.0 -0.625003 530.648188662 0.0 -0.630003 532.214119561 0.0 -0.635003 533.540739846 0.0 -0.640003 534.864997882 0.0 -0.645003 535.705283471 0.0 -0.650003 536.551375318 0.0 -0.655003 537.672993771 0.0 -0.660003 538.293040018 0.0 -0.665003 538.556790426 0.0 -0.670003 538.610440387 0.0 -0.675003 538.368430736 0.0 -0.680003 537.699430445 0.0 -0.685003 536.963245905 0.0 -0.690003 535.870920011 0.0 -0.695003 527.23290401 0.0 -0.700003 528.826007531 0.0 -0.705003 527.32329138 0.0 -0.710003 524.338998477 0.0 -0.715003 521.593027696 0.0 -0.720003 518.649012379 0.0 -0.725003 514.096251176 0.0 -0.730003 509.525715413 0.0 -0.735003 504.947033228 0.0 -0.740003 504.947033228 0.0 -0.745003 501.893347975 0.0 -0.750003 497.120870545 0.0 -0.755003 492.942719649 0.0 -0.760003 488.02326455 0.0 -0.765003 482.401863598 0.0 -0.770003 476.956631729 0.0 -0.775003 471.985411675 0.0 -0.780003 467.217524774 0.0 -0.785003 462.65068765 0.0 -0.790003 458.254624364 0.0 -0.795003 453.789111888 0.0 -0.800003 449.474007299 0.0 -0.805003 445.065203517 0.0 -0.810003 440.80912962 0.0 -0.815003 436.925130517 0.0 -0.820003 432.560820463 0.0 -0.825003 427.874740661 0.0 -0.830003 422.991067115 0.0 -0.835003 417.917359095 0.0 -0.840003 410.910760819 0.0 -0.845003 403.791978835 0.0 -0.850003 397.065985744 0.0 -0.855003 390.765469843 0.0 -0.860003 384.490206451 0.0 -0.865003 384.490206451 0.0 -0.870003 377.778164606 0.0 -0.875003 371.166103108 0.0 -0.880003 364.577357393 0.0 -0.885003 361.187379608 0.0 -0.890003 355.859589919 0.0 -0.895003 350.268258032 0.0 -0.900003 344.4039186 0.0 -0.905003 338.374746974 0.0 -0.910003 332.194292265 0.0 -0.915003 326.653550919 0.0 -0.920003 321.0424104 0.0 -0.925003 311.494316987 0.0 -0.930003 303.103791506 0.0 -0.935003 290.436103093 0.0 -0.940003 274.326959072 0.0 -0.945003 259.575157424 0.0 -0.950003 246.164807144 0.0 -0.955003 233.548392056 0.0 -0.960003 222.663377671 0.0 -0.965003 214.497012976 0.0 -0.970003 208.865001433 0.0 -0.975003 204.500157578 0.0 -0.980003 201.735991652 0.0 -0.985003 201.735991652 0.0 -0.990003 193.243406475 0.0 -0.995003 187.640750386 0.0 -1.000003 182.041097315 0.0 -1.005003 175.927982605 0.0 -1.010003 169.218724331 0.0 -1.015003 162.291401919 0.0 -1.020003 133.458348814 0.0 -1.025003 121.394815225 0.0 -1.030003 121.172145799 0.0 -1.035003 120.795423218 0.0 -1.040003 122.741354238 0.0 -1.045003 122.96513365 0.0 -1.050003 121.406527695 0.0 -1.055003 116.931934253 0.0 -1.060003 112.163982939 0.0 -1.065003 107.199906593 0.0 -1.070003 102.806998795 0.0 -1.075003 97.5442721474 0.0 -1.080003 92.3302530638 0.0 -1.085003 87.0262256489 0.0 -1.090003 87.0262256489 0.0 -1.095003 77.3109657496 0.0 -1.100003 67.8959548156 0.0 -1.105003 67.8959548156 0.0 -1.110003 62.1856310298 0.0 -1.115003 58.0257872571 0.0 -1.120003 53.4237110458 0.0 -1.125003 47.865527289 0.0 -1.130003 41.8023545296 0.0 -1.135003 12.360535003 0.0 -1.140003 -13.0523007332 0.0 -1.145003 -39.3562632555 0.0 -1.150003 -47.0483486341 0.0 -1.155003 -47.5473539225 0.0 -1.160003 -47.5473539225 0.0 -1.165003 -46.453394247 0.0 -1.170003 -34.2075458376 0.0 -1.175003 -32.3060384985 0.0 -1.180003 -21.414226982 0.0 -1.185003 -4.84918639116 0.0 -1.190003 -2.4668889394 0.0 -1.195003 8.00593490082 0.0 -1.200003 8.00593490082 0.0 -1.205003 8.17883966723 0.0 -1.210003 0.487412184428 0.0 -1.215003 -3.072578026 0.0 -1.220003 -6.94640672318 0.0 -1.225003 -18.4596289038 0.0 -1.230003 -35.1662229062 0.0 -1.235003 -53.6874215572 0.0 -1.240003 -53.6874215572 0.0 -1.245003 -105.249912065 0.0 -1.250003 -137.47495592 0.0 -1.255003 -158.414758141 0.0 -1.260003 0.0 0.0 -1.265003 0.0 0.0 -1.270003 0.0 0.0 -1.275003 0.0 0.0 -1.280003 0.0 0.0 -1.285003 0.0 0.0 -1.290003 0.0 0.0 -1.295003 0.0 0.0 -1.300003 0.0 0.0 -1.305003 0.0 0.0 -1.310003 0.0 0.0 -1.315003 0.0 0.0 -1.320003 0.0 0.0 -1.325003 0.0 0.0 -1.330003 0.0 0.0 -1.335003 0.0 0.0 -1.340003 0.0 0.0 -1.345003 0.0 0.0 -1.350003 0.0 0.0 -1.355003 0.0 0.0 -1.360003 0.0 0.0 -1.365003 0.0 0.0 -1.370003 0.0 0.0 -1.375003 0.0 0.0 -1.380003 0.0 0.0 -1.385003 0.0 0.0 -1.390003 0.0 0.0 -1.395003 0.0 0.0 -1.400003 0.0 0.0 -1.405003 0.0 0.0 -1.410003 0.0 0.0 -1.415003 0.0 0.0 -1.420003 0.0 0.0 -1.425003 0.0 0.0 -1.430003 0.0 0.0 -1.435003 0.0 0.0 -1.440003 0.0 0.0 -1.445003 0.0 0.0 -1.450003 0.0 0.0 -1.455003 0.0 0.0 -1.460003 0.0 0.0 -1.465003 0.0 0.0 -1.470003 0.0 0.0 -1.475003 0.0 0.0 -1.480003 0.0 0.0 -1.485003 0.0 0.0 -1.490003 0.0 0.0 -1.495003 0.0 0.0 -1.500003 0.0 0.0 -1.505003 0.0 0.0 -1.510003 0.0 0.0 -1.515003 0.0 0.0 -1.520003 0.0 0.0 -1.525003 0.0 0.0 -1.530003 0.0 0.0 -1.535003 0.0 0.0 -1.540003 0.0 0.0 -1.545003 0.0 0.0 -1.550003 0.0 0.0 -1.555003 0.0 0.0 -1.560003 0.0 0.0 -1.565003 0.0 0.0 -1.570003 0.0 0.0 -1.575003 0.0 0.0 -1.580003 0.0 0.0 -1.585003 0.0 0.0 -1.590003 0.0 0.0 -1.595003 0.0 0.0 -1.600003 0.0 0.0 -1.605003 0.0 0.0 -1.610003 0.0 0.0 -1.615003 0.0 0.0 -1.620003 0.0 0.0 -1.625003 0.0 0.0 -1.630003 0.0 0.0 -1.635003 0.0 0.0 -1.640003 0.0 0.0 -1.645003 0.0 0.0 -1.650003 0.0 0.0 -1.655003 0.0 0.0 -1.660003 0.0 0.0 -1.665003 0.0 0.0 -1.670003 0.0 0.0 -1.675003 0.0 0.0 -1.680003 0.0 0.0 -1.685003 0.0 0.0 -1.690003 0.0 0.0 -1.695003 0.0 0.0 -1.700003 0.0 0.0 -1.705003 0.0 0.0 -1.710003 0.0 0.0 -1.715003 0.0 0.0 -1.720003 0.0 0.0 -1.725003 0.0 0.0 -1.730003 0.0 0.0 -1.735003 0.0 0.0 -1.740003 0.0 0.0 -1.745003 0.0 0.0 -1.750003 0.0 0.0 -1.755003 0.0 0.0 -1.760003 0.0 0.0 -1.765003 0.0 0.0 -1.770003 0.0 0.0 -1.775003 0.0 0.0 -1.780003 0.0 0.0 -1.785003 0.0 0.0 -1.790003 0.0 0.0 -1.795003 0.0 0.0 -1.800003 0.0 0.0 -1.805003 0.0 0.0 -1.810003 0.0 0.0 -1.815003 0.0 0.0 -1.820003 0.0 0.0 -1.825003 0.0 0.0 -1.830003 0.0 0.0 -1.835003 0.0 0.0 -1.840003 0.0 0.0 -1.845003 0.0 0.0 -1.850003 0.0 0.0 -1.855003 0.0 0.0 -1.860003 0.0 0.0 -1.865003 0.0 0.0 -1.870003 0.0 0.0 -1.875003 0.0 0.0 -1.880003 0.0 0.0 -1.885003 0.0 0.0 -1.890003 0.0 0.0 -1.895003 0.0 0.0 -1.900003 0.0 0.0 -1.905003 0.0 0.0 -1.910003 0.0 0.0 -1.915003 0.0 0.0 -1.920003 0.0 0.0 -1.925003 0.0 0.0 -1.930003 0.0 0.0 -1.935003 0.0 0.0 -1.940003 0.0 0.0 -1.945003 0.0 0.0 -1.950003 0.0 0.0 -1.955003 0.0 0.0 -1.960003 0.0 0.0 -1.965003 0.0 0.0 -1.970003 0.0 0.0 -1.975003 0.0 0.0 -1.980003 0.0 0.0 -1.985003 0.0 0.0 -1.990003 0.0 0.0 -1.995003 0.0 0.0 -2.000003 0.0 0.0 -2.005003 0.0 0.0 -2.010003 0.0 0.0 -2.015003 0.0 0.0 -2.020003 0.0 0.0 -2.025003 0.0 0.0 -2.030003 0.0 0.0 -2.035003 0.0 0.0 -2.040003 0.0 0.0 -2.045003 0.0 0.0 -2.050003 0.0 0.0 -2.055003 0.0 0.0 -2.060003 0.0 0.0 -2.065003 0.0 0.0 -2.070003 0.0 0.0 -2.075003 0.0 0.0 -2.080003 0.0 0.0 -2.085003 0.0 0.0 -2.090003 0.0 0.0 -2.095003 0.0 0.0 -2.100003 0.0 0.0 -2.105003 0.0 0.0 -2.110003 0.0 0.0 -2.115003 0.0 0.0 -2.120003 0.0 0.0 -2.125003 0.0 0.0 -2.130003 0.0 0.0 -2.135003 0.0 0.0 -2.140003 0.0 0.0 -2.145003 0.0 0.0 -2.150003 0.0 0.0 -2.155003 0.0 0.0 -2.160003 0.0 0.0 -2.165003 0.0 0.0 -2.170003 0.0 0.0 -2.175003 0.0 0.0 -2.180003 0.0 0.0 -2.185003 0.0 0.0 -2.190003 0.0 0.0 -2.195003 0.0 0.0 -2.200003 0.0 0.0 -2.205003 0.0 0.0 -2.210003 0.0 0.0 -2.215003 0.0 0.0 -2.220003 0.0 0.0 -2.225003 0.0 0.0 -2.230003 0.0 0.0 -2.235003 0.0 0.0 -2.240003 0.0 0.0 -2.245003 0.0 0.0 -2.250003 0.0 0.0 -2.255003 0.0 0.0 -2.260003 0.0 0.0 -2.265003 -2.54663416551 0.0 -2.270003 -2.47785487233 0.0 -2.275003 6.17908656123 0.0 -2.280003 0.764049077831 0.0 -2.285003 0.0 0.0 -2.290003 0.0 0.0 -2.295003 23.1973597779 0.0 -2.300003 58.4576590889 0.0 -2.305003 58.4576590889 0.0 -2.310003 91.974604753 0.0 -2.315003 154.666700643 0.0 -2.320003 178.887865465 0.0 -2.325003 204.859467186 0.0 -2.330003 204.859467186 0.0 -2.335003 192.198649799 0.0 -2.340003 252.488761095 0.0 -2.345003 290.785094356 0.0 -2.350003 290.785094356 0.0 -2.355003 248.974435874 0.0 -2.360003 355.750891668 0.0 -2.365003 355.750891668 0.0 -2.370003 462.747123835 0.0 -2.375003 505.383143199 0.0 -2.380003 505.383143199 0.0 -2.385003 607.001577359 0.0 -2.390003 677.778570202 0.0 -2.395003 677.778570202 0.0 -2.400003 784.211372042 0.0 -2.405003 829.21745448 0.0 -2.410003 829.21745448 0.0 -2.415003 920.766834588 0.0 -2.420003 985.828383426 0.0 -2.425003 985.828383426 0.0 -2.430003 1154.22982207 0.0 -2.435003 1154.22982207 0.0 -2.440003 1172.89355919 0.0 -2.445003 1172.89355919 0.0 -2.450003 1172.89355919 0.0 -2.455003 1172.89355919 0.0 -2.460003 1369.87306988 0.0 -2.465003 1369.87306988 0.0 -2.470003 1369.87306988 0.0 -2.475003 1361.03402047 0.0 -2.480003 1361.03402047 0.0 -2.485003 1426.18246525 0.0 -2.490003 1426.18246525 0.0 -2.495003 1397.98848041 0.0 -2.500003 1396.35697076 0.0 -2.505003 1396.35697076 0.0 -2.510003 1364.90590047 0.0 -2.515003 1273.88422268 0.0 -2.520003 1273.88422268 0.0 -2.525003 1249.62024061 0.0 -2.530003 1137.1154313 0.0 -2.535003 1137.1154313 0.0 -2.540003 1073.73235171 0.0 -2.545003 1001.19611752 0.0 -2.550003 909.608656327 0.0 -2.555003 909.608656327 0.0 -2.560003 859.876550318 0.0 -2.565003 801.708856699 0.0 -2.570003 747.543671618 0.0 -2.575003 727.476510156 0.0 -2.580003 727.476510156 0.0 -2.585003 702.758597428 0.503683145033 -2.590003 664.433200775 -5.69634427028 -2.595003 661.421944729 3.48709416824 -2.600003 640.270036102 -6.35437633579 -2.605003 647.816178297 -0.462050826713 -2.610003 640.167774489 -12.5328409638 -2.615003 659.17959171 -7.04897025205 -2.620003 655.391089109 -26.2356446208 -2.625003 684.963069758 -14.4587269279 -2.630003 699.86661818 -17.1320910842 -2.635003 703.163552779 -22.1272487525 -2.640003 762.744661114 2.14961737662 -2.645003 757.396885116 -25.292394796 -2.650003 822.523709346 0.930876982793 -2.655003 837.546255717 -5.45864278409 -2.660003 846.352092326 -11.8482798261 -2.665003 942.199559717 0.0 -2.670003 960.541280145 0.0 -2.675003 991.021846334 0.0 -2.680003 979.402139806 0.0 -2.685003 1017.5761031 0.0 -2.690003 1008.05701861 0.0 -2.695003 1040.48862293 0.0 -2.700003 1008.98253523 0.0 -2.705003 1039.56161076 0.0 -2.710003 1025.99799141 0.0 -2.715003 1039.6492175 0.0 -2.720003 997.262672591 0.0 -2.725003 945.015609 0.0 -2.730003 951.160727383 0.0 -2.735003 898.427753201 0.0 -2.740003 912.150085344 0.0 -2.745003 887.071792312 0.0 -2.750003 842.277887356 0.0 -2.755003 809.376149896 0.0 -2.760003 792.467078147 0.0 -2.765003 788.957122308 0.0 -2.770003 781.483417278 0.0 -2.775003 775.577689039 0.0 -2.780003 759.316359815 0.0 -2.785003 743.602079729 0.0 -2.790003 741.961081121 0.0 -2.795003 720.905473813 0.0 -2.800003 705.683713365 0.0 -2.805003 692.61443852 0.0 -2.810003 667.500024615 0.0 -2.815003 636.327656232 0.0 -2.820003 608.489417879 0.0 -2.825003 591.129762846 0.0 -2.830003 591.129762846 0.0 -2.835003 567.899805012 0.0 -2.840003 545.652082716 0.0 -2.845003 523.605027683 0.0 -2.850003 503.644680837 0.0 -2.855003 464.244530597 0.0 -2.860003 430.986584636 0.0 -2.865003 392.218312911 0.0 -2.870003 362.462323054 0.0 -2.875003 319.984461673 0.0 -2.880003 295.263082873 0.0 -2.885003 274.823787112 0.0 -2.890003 267.636989815 0.0 -2.895003 238.993130299 0.0 -2.900003 208.884653734 0.0 -2.905003 189.269589724 0.0 -2.910003 178.430479861 0.0 -2.915003 166.528453793 0.0 -2.920003 154.586923809 0.0 -2.925003 152.998218242 0.0 -2.930003 149.949535775 0.0 -2.935003 145.317146517 0.0 -2.940003 143.774363497 0.0 -2.945003 136.744214341 0.0 -2.950003 130.232341192 0.0 -2.955003 124.771918082 0.0 -2.960003 123.156259815 0.0 -2.965003 122.704865032 0.0 -2.970003 124.753405055 0.0 -2.975003 129.064337401 0.0 -2.980003 129.354900183 0.0 -2.985003 128.789876449 0.0 -2.990003 128.475368173 0.0 -2.995003 120.153204359 0.0 -3.000003 108.137661114 0.0 -3.005003 97.8757227148 0.0 -3.010003 81.3168671017 0.0 -3.015003 64.5143225382 0.0 -3.020003 54.7423564144 0.0 -3.025003 41.9445859356 0.0 -3.030003 32.3138709956 0.0 -3.035003 21.4058870183 0.0 -3.040003 9.69077186869 0.0 -3.045003 -0.706164341961 0.0 -3.050003 -12.9044845435 0.0 -3.055003 -27.1890233141 0.0 -3.060003 -39.1501926816 0.0 -3.065003 -54.0669236033 0.0 -3.070003 -64.9291654133 0.0 -3.075003 -76.6937688269 0.0 -3.080003 -76.6937688269 0.0 -3.085003 -90.8261106503 0.0 -3.090003 -91.8578431196 0.0 -3.095003 -93.7930655218 0.0 -3.100003 -102.694490861 0.0 -3.105003 -117.471865188 0.0 -3.110003 -126.944398023 0.0 -3.115003 -133.11325117 0.0 -3.120003 -149.806992858 0.0 -3.125003 -150.620308618 0.0 -3.130003 -139.636736718 0.0 -3.135003 -144.564654686 0.0 -3.140003 0.0 0.0 -3.145003 0.0 0.0 -3.150003 0.0 0.0 -3.155003 0.0 0.0 -3.160003 0.0 0.0 -3.165003 0.0 0.0 -3.170003 0.0 0.0 -3.175003 0.0 0.0 -3.180003 0.0 0.0 -3.185003 0.0 0.0 -3.190003 0.0 0.0 -3.195003 0.0 0.0 -3.200003 0.0 0.0 -3.205003 0.0 0.0 -3.210003 0.0 0.0 -3.215003 0.0 0.0 -3.220003 0.0 0.0 -3.225003 0.0 0.0 -3.230003 0.0 0.0 -3.235003 0.0 0.0 -3.240003 0.0 0.0 -3.245003 0.0 0.0 -3.250003 0.0 0.0 -3.255003 0.0 0.0 -3.260003 0.0 0.0 -3.265003 0.0 0.0 -3.270003 0.0 0.0 -3.275003 0.0 0.0 -3.280003 0.0 0.0 -3.285003 0.0 0.0 -3.290003 0.0 0.0 -3.295003 0.0 0.0 -3.300003 0.0 0.0 -3.305003 0.0 0.0 -3.310003 0.0 0.0 -3.315003 0.0 0.0 -3.320003 0.0 0.0 -3.325003 0.0 0.0 -3.330003 0.0 0.0 -3.335003 0.0 0.0 -3.340003 0.0 0.0 -3.345003 0.0 0.0 -3.350003 0.0 0.0 -3.355003 0.0 0.0 -3.360003 0.0 0.0 -3.365003 0.0 0.0 -3.370003 0.0 0.0 -3.375003 0.0 0.0 -3.380003 0.0 0.0 -3.385003 0.0 0.0 -3.390003 0.0 0.0 -3.395003 0.0 0.0 -3.400003 0.0 0.0 -3.405003 0.0 0.0 -3.410003 0.0 0.0 -3.415003 0.0 0.0 -3.420003 0.0 0.0 -3.425003 0.0 0.0 -3.430003 0.0 0.0 -3.435003 0.0 0.0 -3.440003 0.0 0.0 -3.445003 0.0 0.0 -3.450003 0.0 0.0 -3.455003 0.0 0.0 -3.460003 0.0 0.0 -3.465003 0.0 0.0 -3.470003 0.0 0.0 -3.475003 0.0 0.0 -3.480003 0.0 0.0 -3.485003 0.0 0.0 -3.490003 0.0 0.0 -3.495003 0.0 0.0 -3.500003 0.0 0.0 -3.505003 0.0 0.0 -3.510003 0.0 0.0 -3.515003 0.0 0.0 -3.520003 0.0 0.0 -3.525003 0.0 0.0 -3.530003 0.0 0.0 -3.535003 0.0 0.0 -3.540003 0.0 0.0 -3.545003 0.0 0.0 -3.550003 0.0 0.0 -3.555003 0.0 0.0 -3.560003 0.0 0.0 -3.565003 0.0 0.0 -3.570003 0.0 0.0 -3.575003 0.0 0.0 -3.580003 0.0 0.0 -3.585003 0.0 0.0 -3.590003 0.0 0.0 -3.595003 0.0 0.0 -3.600003 0.0 0.0 -3.605003 0.0 0.0 -3.610003 0.0 0.0 -3.615003 0.0 0.0 -3.620003 0.0 0.0 -3.625003 0.0 0.0 -3.630003 0.0 0.0 -3.635003 0.0 0.0 -3.640003 0.0 0.0 -3.645003 0.0 0.0 -3.650003 0.0 0.0 -3.655003 0.0 0.0 -3.660003 0.0 0.0 -3.665003 0.0 0.0 -3.670003 0.0 0.0 -3.675003 0.0 0.0 -3.680003 0.0 0.0 -3.685003 0.0 0.0 -3.690003 0.0 0.0 -3.695003 0.0 0.0 -3.700003 0.0 0.0 -3.705003 0.0 0.0 -3.710003 0.0 0.0 -3.715003 0.0 0.0 -3.720003 0.0 0.0 -3.725003 0.0 0.0 -3.730003 0.0 0.0 -3.735003 0.0 0.0 -3.740003 0.0 0.0 -3.745003 0.0 0.0 -3.750003 0.0 0.0 -3.755003 0.0 0.0 -3.760003 0.0 0.0 -3.765003 0.0 0.0 -3.770003 0.0 0.0 -3.775003 0.0 0.0 -3.780003 0.0 0.0 -3.785003 0.0 0.0 -3.790003 0.0 0.0 -3.795003 0.0 0.0 -3.800003 0.0 0.0 -3.805003 0.0 0.0 -3.810003 0.0 0.0 -3.815003 0.0 0.0 -3.820003 0.0 0.0 -3.825003 0.0 0.0 -3.830003 0.0 0.0 -3.835003 0.0 0.0 -3.840003 0.0 0.0 -3.845003 0.0 0.0 -3.850003 0.0 0.0 -3.855003 0.0 0.0 -3.860003 0.0 0.0 -3.865003 0.0 0.0 -3.870003 0.0 0.0 -3.875003 0.0 0.0 -3.880003 0.0 0.0 -3.885003 0.0 0.0 -3.890003 0.0 0.0 -3.895003 0.0 0.0 -3.900003 0.0 0.0 -3.905003 0.0 0.0 -3.910003 0.0 0.0 -3.915003 0.0 0.0 -3.920003 0.0 0.0 -3.925003 0.0 0.0 -3.930003 0.0 0.0 -3.935003 0.0 0.0 -3.940003 0.0 0.0 -3.945003 0.0 0.0 -3.950003 0.0 0.0 -3.955003 0.0 0.0 -3.960003 0.0 0.0 -3.965003 0.0 0.0 -3.970003 0.0 0.0 -3.975003 0.0 0.0 -3.980003 0.0 0.0 -3.985003 0.0 0.0 -3.990003 0.0 0.0 -3.995003 0.0 0.0 -4.000003 0.0 0.0 -4.005003 0.0 0.0 -4.010003 0.0 0.0 -4.015003 0.0 0.0 -4.020003 0.0 0.0 -4.025003 0.0 0.0 -4.030003 0.0 0.0 -4.035003 0.0 0.0 -4.040003 0.0 0.0 -4.045003 0.0 0.0 -4.050003 0.0 0.0 -4.055003 0.0 0.0 -4.060003 0.0 0.0 -4.065003 0.0 0.0 -4.070003 0.0 0.0 -4.075003 0.0 0.0 -4.080003 0.0 0.0 -4.085003 0.0 0.0 -4.090003 0.0 0.0 -4.095003 0.0 0.0 -4.100003 0.0 0.0 -4.105003 0.0 0.0 -4.110003 0.0 0.0 -4.115003 0.0 0.0 -4.120003 0.0 0.0 -4.125003 0.0 0.0 -4.130003 0.0 0.0 -4.135003 0.0 0.0 -4.140003 0.0 0.0 -4.145003 0.0 0.0 -4.150003 0.0 0.0 -4.155003 0.0 0.0 -4.160003 0.0 0.0 -4.165003 0.0 0.0 -4.170003 0.0 0.0 -4.175003 0.0 0.0 -4.180003 0.0 0.0 -4.185003 0.0 0.0 -4.190003 0.0 0.0 -4.195003 0.0 0.0 -4.200003 0.0 0.0 -4.205003 0.0 0.0 -4.210003 0.0 0.0 -4.215003 0.0 0.0 -4.220003 0.0 0.0 -4.225003 0.0 0.0 -4.230003 0.0 0.0 -4.235003 0.0 0.0 -4.240003 0.0 0.0 -4.245003 0.0 0.0 -4.250003 0.0 0.0 -4.255003 0.0 0.0 -4.260003 0.0 0.0 -4.265003 0.0 0.0 -4.270003 0.0 0.0 -4.275003 0.0 0.0 -4.280003 0.0 0.0 -4.285003 0.0 0.0 -4.290003 0.0 0.0 -4.295003 0.0 0.0 -4.300003 -125.472189489 0.0 -4.305003 -88.064112395 0.0 -4.310003 61.7109683716 0.0 -4.315003 -42.3095305322 0.0 -4.320003 -110.659409442 0.0 -4.325003 -89.928646609 0.0 -4.330003 -46.0980494597 0.0 -4.335003 -126.315761295 0.0 -4.340003 -114.323662296 0.0 -4.345003 -90.9476634148 0.0 -4.350003 -79.1398014477 0.0 -4.355003 56.78146447 0.0 -4.360003 205.77388095 0.0 -4.365003 205.77388095 0.0 -4.370003 197.298231562 0.0 -4.375003 207.034344678 0.0 -4.380003 207.034344678 0.0 -4.385003 207.034344678 0.0 -4.390003 207.034344678 0.0 -4.395003 518.417918304 0.0 -4.400003 518.417918304 0.0 -4.405003 1070.21427321 0.0 -4.410003 1070.21427321 0.0 -4.415003 1070.21427321 0.0 -4.420003 1070.21427321 0.0 -4.425003 1070.21427321 0.0 -4.430003 1287.10150645 0.0 -4.435003 1287.10150645 0.0 -4.440003 1398.69073956 0.0 -4.445003 1381.43626492 0.0 -4.450003 1381.43626492 0.0 -4.455003 1360.98051696 0.0 -4.460003 1330.66665924 0.0 -4.465003 1259.99737913 0.0 -4.470003 1259.99737913 0.0 -4.475003 1268.19531135 0.0 -4.480003 1268.19531135 0.0 -4.485003 1089.53567913 0.0 -4.490003 1089.53567913 0.0 -4.495003 1089.53567913 0.0 -4.500003 917.761971815 0.0 -4.505003 917.761971815 0.0 -4.510003 807.188592514 0.0 -4.515003 807.188592514 0.0 -4.520003 764.710866049 0.0 -4.525003 764.710866049 0.0 -4.530003 677.357507476 0.0 -4.535003 559.468480817 0.0 -4.540003 559.468480817 0.0 -4.545003 476.791633308 0.0 -4.550003 476.791633308 0.0 -4.555003 505.385293848 -17.144204917 -4.560003 505.385293848 -17.144204917 -4.565003 505.385293848 -17.144204917 -4.570003 451.66225638 -32.6233327513 -4.575003 392.978386618 -40.2438782036 -4.580003 392.978386618 -40.2438782036 -4.585003 392.978386618 -40.2438782036 -4.590003 392.978386618 -40.2438782036 -4.595003 392.978386618 -40.2438782036 -4.600003 458.962952658 -52.3288189354 -4.605003 428.014108779 -62.2685219985 -4.610003 407.970868973 -62.4125711964 -4.615003 407.970868973 0.0 -4.620003 440.502808499 0.0 -4.625003 496.45157795 0.0 -4.630003 511.122248508 0.0 -4.635003 536.522690028 0.0 -4.640003 585.854210638 0.0 -4.645003 585.854210638 0.0 -4.650003 610.452340276 0.0 -4.655003 611.416639781 0.0 -4.660003 619.089176326 0.0 -4.665003 621.508675786 0.0 -4.670003 622.248593146 0.0 -4.675003 621.267788322 0.0 -4.680003 617.35991553 0.0 -4.685003 613.235423954 0.0 -4.690003 613.235423954 0.0 -4.695003 615.261877022 0.0 -4.700003 608.533824321 0.0 -4.705003 596.642840497 0.0 -4.710003 570.816342487 0.0 -4.715003 557.172040517 0.0 -4.720003 557.172040517 0.0 -4.725003 572.972171038 -16.2893022583 -4.730003 572.972171038 -16.2893022583 -4.735003 570.574433661 -21.1899007135 -4.740003 570.574433661 -21.1899007135 -4.745003 563.534913775 -35.0301718283 -4.750003 555.979510421 -35.7212405088 -4.755003 555.979510421 -35.7212405088 -4.760003 535.308962819 -50.9307588071 -4.765003 497.108179452 -51.2949956645 -4.770003 497.108179452 -51.2949956645 -4.775003 519.025203301 -66.3750225024 -4.780003 519.025203301 -66.3750225024 -4.785003 519.025203301 0.0 -4.790003 551.066000524 0.0 -4.795003 551.066000524 0.0 -4.800003 519.582046568 0.0 -4.805003 519.582046568 0.0 -4.810003 507.953772937 0.0 -4.815003 507.953772937 0.0 -4.820003 512.957982158 0.0 -4.825003 512.957982158 0.0 -4.830003 526.175228612 0.0 -4.835003 526.175228612 0.0 -4.840003 496.725602181 0.0 -4.845003 496.725602181 0.0 -4.850003 510.687381563 0.0 -4.855003 510.687381563 0.0 -4.860003 510.687381563 0.0 -4.865003 471.846941557 0.0 -4.870003 471.846941557 0.0 -4.875003 471.846941557 0.0 -4.880003 468.414933071 0.0 -4.885003 468.414933071 0.0 -4.890003 310.626291419 0.0 -4.895003 310.626291419 0.0 -4.900003 310.626291419 0.0 -4.905003 172.276572747 0.0 -4.910003 172.276572747 0.0 -4.915003 172.276572747 0.0 -4.920003 -34.032013758 0.0 -4.925003 -253.914534034 0.0 -4.930003 -185.590847019 0.0 -4.935003 139.738298733 0.0 -4.940003 215.372919457 0.0 -4.945003 196.789912592 0.0 -4.950003 127.841837759 0.0 -4.955003 49.1764003081 0.0 -4.960003 -0.517062495053 0.0 -4.965003 0.0 0.0 -4.970003 0.0 0.0 -4.975003 0.0 0.0 -4.980003 0.0 0.0 -4.985003 0.0 0.0 -4.990003 0.0 0.0 -4.995003 0.0 0.0 -5.000003 0.0 0.0 -5.005003 0.0 0.0 -5.010003 0.0 0.0 -5.015003 0.0 0.0 -5.020003 0.0 0.0 -5.025003 0.0 0.0 -5.030003 0.0 0.0 -5.035003 0.0 0.0 -5.040003 0.0 0.0 -5.045003 0.0 0.0 -5.050003 0.0 0.0 -5.055003 0.0 0.0 -5.060003 0.0 0.0 -5.065003 0.0 0.0 -5.070003 0.0 0.0 -5.075003 0.0 0.0 -5.080003 0.0 0.0 -5.085003 0.0 0.0 -5.090003 0.0 0.0 -5.095003 0.0 0.0 -5.100003 0.0 0.0 -5.105003 0.0 0.0 -5.110003 0.0 0.0 -5.115003 0.0 0.0 -5.120003 0.0 0.0 -5.125003 0.0 0.0 -5.130003 0.0 0.0 -5.135003 0.0 0.0 -5.140003 0.0 0.0 -5.145003 0.0 0.0 -5.150003 0.0 0.0 -5.155003 0.0 0.0 -5.160003 0.0 0.0 -5.165003 0.0 0.0 -5.170003 9.166091151 0.0 -5.175003 9.166091151 0.0 -5.180003 -10.6508762358 0.0 -5.185003 -28.7701815868 0.0 diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history.csv b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history.csv deleted file mode 100644 index 61d6d35b2355..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history.csv +++ /dev/null @@ -1,1894 +0,0 @@ -time (0.0,0.093) (0.0,0.299) -1e-06 0.0 0.0 -2e-06 0.0 0.0 -3e-06 0.0 0.0 -0.010003 13.6458027459 0.0 -0.020003 35.5339476385 0.0 -0.030003 48.1628818419 0.0 -0.040003 79.8593173393 0.0 -0.050003 88.8856072195 0.0 -0.060003 93.4290167638 0.0 -0.0620034372578 85.5417614313 0.0 -0.0667173296641 88.8289610107 0.0 -0.0722828510861 90.4727614731 0.0 -0.078396753084 91.98809847 0.0 -0.0845942095705 91.7380987276 0.0 -0.0903574997394 93.460323323 0.0 -0.0968804986609 96.3181592528 0.0 -0.104738761051 99.4780235877 0.0 -0.111801259181 101.386154824 0.0 -0.118924893811 102.946847244 0.0 -0.126636834523 104.663258648 0.0 -0.136636834523 107.553461785 0.0 -0.146636834523 110.141752788 0.0 -0.156636834523 112.718325818 0.0 -0.166636834523 115.348569142 0.0 -0.176636834523 121.355816373 0.0 -0.184826431518 125.474043816 0.0 -0.194826431518 129.821844367 0.0 -0.204826431518 134.047145037 0.0 -0.214826431518 137.791689527 0.0 -0.224826431518 140.904890016 0.0 -0.234826431518 143.370572584 0.0 -0.244826431518 149.474468922 0.0 -0.254826431518 153.016081621 0.0 -0.264826431518 156.112290538 0.0 -0.274826431518 157.311616153 0.0 -0.284826431518 158.3980042 0.0 -0.294826431518 156.565730029 0.0 -0.304826431518 155.785911482 0.0 -0.314826431518 156.168662332 0.0 -0.324826431518 158.071536138 0.0 -0.334826431518 161.345513401 0.0 -0.344826431518 165.655074438 0.0 -0.354826431518 171.456476933 0.0 -0.364826431518 177.371855671 0.0 -0.374826431518 183.505250032 0.0 -0.384826431518 189.280507487 0.0 -0.394826431518 194.548566403 0.0 -0.404826431518 199.348004536 0.0 -0.414826431518 203.695369517 0.0 -0.424826431518 208.640307508 0.0 -0.434826431518 212.609855638 0.0 -0.444826431518 216.984762562 0.0 -0.454826431518 221.060576353 0.0 -0.464826431518 225.225943812 0.0 -0.474826431518 229.264898875 0.0 -0.484826431518 233.07906528 0.0 -0.494826431518 235.909999132 0.0 -0.504826431518 239.45681684 0.0 -0.514826431518 242.437783734 0.0 -0.524826431518 245.808204767 0.0 -0.534826431518 249.413210509 0.0 -0.544826431518 253.183340799 0.0 -0.554826431518 256.9650119 0.0 -0.564826431518 260.658507189 0.0 -0.574826431518 264.783180034 0.0 -0.584826431518 267.824043925 0.0 -0.594826431518 271.031065984 0.0 -0.604826431518 274.775013273 0.0 -0.614826431518 279.513129737 0.0 -0.624826431518 284.32264028 0.0 -0.634826431518 287.587043357 0.0 -0.644826431518 291.977884273 0.0 -0.654826431518 295.393903732 0.0 -0.664826431518 298.073144173 0.0 -0.674826431518 300.218595561 0.0 -0.684826431518 301.754354712 0.0 -0.694826431518 303.114545752 0.0 -0.704826431518 304.104989486 0.0 -0.714826431518 300.186364795 0.0 -0.724826431518 302.039079009 0.0 -0.734826431518 300.786792708 0.0 -0.744826431518 300.7640899 0.0 -0.754826431518 301.211526071 0.0 -0.764826431518 302.357601663 0.0 -0.774826431518 303.72028205 0.0 -0.784826431518 304.038857901 0.0 -0.794826431518 305.805876638 0.0 -0.804826431518 305.448681832 0.0 -0.814826431518 303.81876862 0.0 -0.824826431518 300.177402928 0.0 -0.834826431518 300.258734536 0.0 -0.844826431518 300.309449165 0.0 -0.854826431518 294.979251552 0.0 -0.864826431518 295.865400392 0.0 -0.874826431518 293.098460539 0.0 -0.884826431518 289.858718756 0.0 -0.894826431518 283.826803764 0.0 -0.904826431518 282.248643713 0.0 -0.914826431518 279.515968542 0.0 -0.924826431518 274.423950187 0.0 -0.934826431518 269.336270159 0.0 -0.944826431518 266.886235346 0.0 -0.954826431518 262.380346056 0.0 -0.964826431518 253.667236971 0.0 -0.974826431518 249.655716897 0.0 -0.984826431518 246.818511214 0.0 -0.994826431518 241.60588364 0.0 -1.00482643152 233.085071407 0.0 -1.01482643152 229.703755195 0.0 -1.02482643152 223.512175658 0.0 -1.03482643152 211.722424304 0.0 -1.04482643152 204.036658662 0.0 -1.05482643152 196.920931755 0.0 -1.06482643152 189.577414382 0.0 -1.07482643152 182.771245582 0.0 -1.08482643152 174.258491232 0.0 -1.09113529771 167.025967806 0.0 -1.10113529771 159.875934717 0.0 -1.11113529771 149.300037195 0.0 -1.12113529771 137.156868706 0.0 -1.13113529771 136.980803168 0.0 -1.14113529771 129.168889913 0.0 -1.15113529771 100.767975205 0.0 -1.16113529771 88.7234447014 0.0 -1.17113529771 78.9682264844 0.0 -1.18113529771 71.309988407 0.0 -1.19113529771 70.4303543115 0.0 -1.20113529771 46.750657655 0.0 -1.21113529771 43.9492109576 0.0 -1.22113529771 36.2032751584 0.0 -1.23113529771 29.7964999622 0.0 -1.24113529771 26.5590475242 0.0 -1.25113529771 23.4191116721 0.0 -1.26113529771 24.8223078919 0.0 -1.27113529771 1.80751988979 0.0 -1.28113529771 -14.2035512132 0.0 -1.29113529771 -16.7022108217 0.0 -1.30113529771 -20.112033869 0.0 -1.31113529771 0.984445741018 0.0 -1.32113529771 -13.3557770493 0.0 -1.32498810195 -65.2228430136 0.0 -1.33092346588 -112.575765976 0.0 -1.34092346588 -27.8703705856 0.0 -1.35092346588 -85.8510013971 0.0 -1.36092346588 -94.5229830417 0.0 -1.37092346588 -92.1578377582 0.0 -1.38092346588 0.0 0.0 -1.39092346588 0.0 0.0 -1.40092346588 0.0 0.0 -1.41092346588 0.0 0.0 -1.42092346588 0.0 0.0 -1.43092346588 0.0 0.0 -1.4403398463 0.0 0.0 -1.4503398463 0.0 0.0 -1.4603398463 0.0 0.0 -1.4703398463 0.0 0.0 -1.4803398463 0.0 0.0 -1.4903398463 0.0 0.0 -1.5003398463 0.0 0.0 -1.5103398463 0.0 0.0 -1.5203398463 0.0 0.0 -1.5303398463 0.0 0.0 -1.5403398463 0.0 0.0 -1.5503398463 0.0 0.0 -1.55945733841 0.0 0.0 -1.56945733841 0.0 0.0 -1.57945733841 0.0 0.0 -1.58945733841 0.0 0.0 -1.59945733841 0.0 0.0 -1.60945733841 0.0 0.0 -1.61945733841 0.0 0.0 -1.62945733841 0.0 0.0 -1.63945733841 0.0 0.0 -1.64945733841 0.0 0.0 -1.65945733841 0.0 0.0 -1.66945733841 0.0 0.0 -1.67945733841 0.0 0.0 -1.68945733841 0.0 0.0 -1.69945733841 0.0 0.0 -1.70945733841 0.0 0.0 -1.71924151237 0.0 0.0 -1.72638876152 0.0 0.0 -1.73638796206 0.0 0.0 -1.74638796206 0.0 0.0 -1.75638796206 0.0 0.0 -1.76638796206 0.0 0.0 -1.77638796206 0.0 0.0 -1.78638796206 0.0 0.0 -1.79638796206 0.0 0.0 -1.80638796206 0.0 0.0 -1.81638796206 0.0 0.0 -1.82638796206 0.0 0.0 -1.83638796206 0.0 0.0 -1.84638796206 0.0 0.0 -1.85638796206 0.0 0.0 -1.86638796206 0.0 0.0 -1.87638796206 0.0 0.0 -1.88638796206 0.0 0.0 -1.89638796206 0.0 0.0 -1.90638796206 0.0 0.0 -1.91638796206 0.0 0.0 -1.92638796206 0.0 0.0 -1.93638796206 0.0 0.0 -1.94638796206 0.0 0.0 -1.95638796206 0.0 0.0 -1.96638796206 0.0 0.0 -1.97638796206 0.0 0.0 -1.98638796206 0.0 0.0 -1.99638796206 0.0 0.0 -2.00638796206 0.0 0.0 -2.01638796206 0.0 0.0 -2.02638796206 0.0 0.0 -2.03638796206 0.0 0.0 -2.04638796206 0.0 0.0 -2.05638796206 0.0 0.0 -2.06638796206 0.0 0.0 -2.07638796206 0.0 0.0 -2.08638796206 0.0 0.0 -2.09366999468 0.0 0.0 -2.10320450746 0.0 0.0 -2.11320450746 0.0 0.0 -2.12320450746 0.0 0.0 -2.13320450746 0.0 0.0 -2.14320450746 0.0 0.0 -2.15320450746 0.0 0.0 -2.16320450746 0.0 0.0 -2.17320450746 0.0 0.0 -2.18320450746 0.0 0.0 -2.19320450746 0.0 0.0 -2.20320450746 0.0 0.0 -2.21320450746 0.0 0.0 -2.22320450746 0.0 0.0 -2.22876686106 0.0 0.0 -2.22926686106 0.0 0.0 -2.23926686106 0.0 0.0 -2.24233237852 0.0 0.0 -2.25181500746 0.0 0.0 -2.26181500746 0.0 0.0 -2.27181500746 0.0 0.0 -2.28129184898 0.0 0.0 -2.29129184898 0.0 0.0 -2.30129184898 0.0 0.0 -2.31118396656 44.0372709245 0.0 -2.32118396656 78.1465531022 0.0 -2.33118396656 221.430243078 0.0 -2.34118396656 262.089845492 0.0 -2.35118396656 531.266661757 0.0 -2.35788602175 710.600770405 0.0 -2.36676620383 742.305884618 0.0 -2.37633928443 795.169488915 0.0 -2.38354959233 872.66698229 0.0 -2.38706115994 856.123510787 0.0 -2.39075765674 822.763317205 0.0 -2.39539675755 798.909557617 0.0 -2.39987613852 754.004499145 0.0 -2.40598855107 732.840090696 0.0 -2.41236999597 716.863194014 0.0 -2.41911072559 707.313717025 0.0 -2.42633813465 695.580632841 0.0 -2.43556069338 693.36703969 0.0 -2.44556069338 686.722300646 0.0 -2.45556069338 682.096670044 0.0 -2.46556069338 674.785191423 0.0 -2.47556069338 671.024591582 0.0 -2.48556069338 669.763052244 0.0 -2.49556069338 674.421509809 0.0 -2.50556069338 680.457413786 0.0 -2.51464443436 689.586014231 0.0 -2.51719926665 689.67332884 0.0 -2.51832191362 676.937560485 0.0 -2.52832191362 690.632098689 5.69724831219 -2.53832191362 714.964236488 0.0 -2.54832191362 742.876995293 0.0 -2.55832191362 758.205042098 0.0 -2.56832191362 797.770692729 0.0 -2.57832191362 813.453765166 0.0 -2.58832191362 842.839520657 0.0 -2.59832191362 887.110661795 0.0 -2.60832191362 902.320821936 0.0 -2.61832191362 917.854150738 0.0 -2.62832191362 951.756217645 0.0 -2.63832191362 969.571056219 0.0 -2.64832191362 967.16327788 0.0 -2.65827494218 957.096869686 0.0 -2.66827494218 931.49627488 3.2197423638 -2.67827494218 879.880044108 0.0 -2.68827494218 855.136876995 0.0 -2.69827494218 791.506324199 0.0 -2.70827494218 742.054205373 0.0 -2.71827494218 695.06244852 0.0 -2.72827494218 657.43440963 0.0 -2.73827494218 625.927660233 0.0 -2.74827494218 596.633802067 0.0 -2.75827494218 577.398543978 0.0 -2.76827494218 555.632200806 0.0 -2.77827494218 550.708531805 0.0 -2.78827494218 535.997058873 0.0 -2.79827494218 516.07608454 0.0 -2.80827494218 501.298510675 0.0 -2.81827494218 501.442851864 0.0 -2.82827494218 495.32879785 0.0 -2.83827494218 471.519553479 0.0 -2.84827494218 469.339017835 0.0 -2.85827494218 455.082079816 0.0 -2.86272791487 437.987255264 0.0 -2.87272791487 424.233838981 0.0 -2.88072647543 411.677937111 0.0 -2.89072647543 402.448759498 0.0 -2.90072647543 392.479732258 0.0 -2.91072647543 381.76047243 0.0 -2.92072647543 368.071623081 0.0 -2.92900858279 364.643083439 0.0 -2.93900858279 360.960296492 0.0 -2.94539513667 357.285795773 0.0 -2.95539513667 350.272280587 0.0 -2.96539513667 339.611470439 0.0 -2.97539513667 322.920555383 0.0 -2.97690450712 378.388474217 0.0 -2.9857957722 348.550381037 0.0 -2.9862957722 133.541589071 0.0 -2.99230310409 303.981103483 0.0 -2.99756892638 320.672274146 0.0 -3.00042789415 540.547286365 0.0 -3.00092789415 536.58181823 0.0 -3.00202717556 409.849702357 0.0 -3.00443653997 432.409831238 0.0 -3.00860015524 405.3692902 0.0 -3.01405927922 369.921554278 0.0 -3.01651279214 257.884405419 0.0 -3.02200053628 240.825230626 0.0 -3.02334083359 124.930330392 0.0 -3.02865057377 131.0928591 0.0 -3.03111780116 152.968304053 0.0 -3.03492763858 166.74513098 0.0 -3.04118323559 170.440082174 0.0 -3.04510681915 217.000656741 0.0 -3.04970939817 247.677429249 0.0 -3.05540602544 266.392459468 0.0 -3.06212815773 281.761689851 0.0 -3.06932243041 285.810462085 0.0 -3.07607588204 272.33097484 0.0 -3.08190250431 262.426202398 0.0 -3.08600615524 244.905228448 0.0 -3.08875816533 227.310674473 0.0 -3.09148868469 213.767516979 0.0 -3.09471605031 198.663235098 0.0 -3.09632639188 181.930672449 0.0 -3.09733131346 171.835506272 0.0 -3.09783131346 152.832615829 0.0 -3.09901126068 148.060543133 0.0 -3.10133915135 139.660061946 0.0 -3.10460851552 138.319277945 0.0 -3.10616779535 147.201890942 0.0 -3.1095541258 145.236613651 0.0 -3.11695435699 138.953975532 0.0 -3.12410661625 132.854777839 0.0 -3.13032708581 129.209715728 0.0 -3.13628337305 125.558886084 0.0 -3.14598759798 116.534914114 0.0 -3.14806532926 122.121701588 0.0 -3.15035599927 153.881277776 0.0 -3.15403553161 158.958869501 0.0 -3.15872313168 104.2318209 0.0 -3.16292422634 139.072508303 0.0 -3.16800699186 119.033421705 0.0 -3.17172944748 107.772809844 0.0 -3.17689420668 75.2159268672 0.0 -3.17947277224 22.5480971891 0.0 -3.18310309029 23.5885712039 0.0 -3.18763087297 25.604781909 0.0 -3.18899970169 32.6977864314 0.0 -3.19181560261 32.2566246775 0.0 -3.19644051995 36.2117705796 0.0 -3.19729754473 49.6827454086 0.0 -3.19826371195 41.5458345759 0.0 -3.20113188783 32.4383541931 0.0 -3.20376925614 17.6977348658 0.0 -3.20832508288 10.6568746994 0.0 -3.21390429524 5.00839320118 0.0 -3.21581790636 -2.34756808146 0.0 -3.221804608 -9.0673273806 0.0 -3.22255063182 15.3867014947 0.0 -3.2248467189 9.95344575419 0.0 -3.22931980301 0.901518582581 0.0 -3.23441989146 -18.240748533 0.0 -3.23585336433 -55.9319876967 0.0 -3.2392378949 -39.7363721161 0.0 -3.24327512299 1.65990657652 0.0 -3.24865061678 -10.6123790731 0.0 -3.2545559001 -34.3483711508 0.0 -3.25644265902 -25.0910370413 0.0 -3.26107764825 -39.7389830975 0.0 -3.26811892885 -49.1178308402 0.0 -3.27531389999 -40.3178326167 0.0 -3.27837216271 -19.0402724817 0.0 -3.28134541875 -11.6552317386 0.0 -3.28812446125 -27.1861383482 0.0 -3.29498197406 -38.4963595375 0.0 -3.30074110206 -42.1521425136 0.0 -3.30317468651 -44.4043315488 0.0 -3.3050877657 -45.3644822803 0.0 -3.30828766582 -48.4694050757 0.0 -3.31239122158 -55.1236724412 0.0 -3.31996205241 0.0 0.0 -3.32828705282 0.0 0.0 -3.33459805456 0.0 0.0 -3.34059409852 0.0 0.0 -3.34542061705 0.0 0.0 -3.35040381882 0.0 0.0 -3.35681320824 0.0 0.0 -3.36246527772 0.0 0.0 -3.36562898494 0.0 0.0 -3.36636779472 0.0 0.0 -3.36752287587 0.0 0.0 -3.36983701545 0.0 0.0 -3.37471837042 0.0 0.0 -3.38240106699 0.0 0.0 -3.39240106699 0.0 0.0 -3.39732119705 0.0 0.0 -3.40391876566 0.0 0.0 -3.40639112927 0.0 0.0 -3.41094498716 0.0 0.0 -3.41491679563 0.0 0.0 -3.4209440466 0.0 0.0 -3.42655223923 0.0 0.0 -3.43255886613 0.0 0.0 -3.4412214804 0.0 0.0 -3.44866026292 0.0 0.0 -3.4558009208 0.0 0.0 -3.4658009208 0.0 0.0 -3.47487122439 0.0 0.0 -3.48433611658 0.0 0.0 -3.49433611658 0.0 0.0 -3.49964318237 0.0 0.0 -3.50798079517 0.0 0.0 -3.5165985649 0.0 0.0 -3.52283698769 0.0 0.0 -3.53068391069 0.0 0.0 -3.53909341429 0.0 0.0 -3.54735261261 0.0 0.0 -3.55569127162 0.0 0.0 -3.56253428043 0.0 0.0 -3.56348528389 0.0 0.0 -3.57156632123 0.0 0.0 -3.57912289905 0.0 0.0 -3.58548126086 0.0 0.0 -3.58608900144 0.0 0.0 -3.59302765237 0.0 0.0 -3.59963954353 0.0 0.0 -3.60534033455 0.0 0.0 -3.61145455638 0.0 0.0 -3.61699828144 0.0 0.0 -3.62292876016 0.0 0.0 -3.63016462642 0.0 0.0 -3.64016462642 0.0 0.0 -3.6485745139 0.0 0.0 -3.65762400676 0.0 0.0 -3.66719302705 0.0 0.0 -3.67697362027 0.0 0.0 -3.67873924755 0.0 0.0 -3.68096576742 0.0 0.0 -3.68302075987 0.0 0.0 -3.68594404337 0.0 0.0 -3.69031158713 0.0 0.0 -3.69411591242 0.0 0.0 -3.69665841866 0.0 0.0 -3.70130676679 0.0 0.0 -3.70324248234 0.0 0.0 -3.71322172726 0.0 0.0 -3.71492887357 0.0 0.0 -3.71682147201 0.0 0.0 -3.71911663489 0.0 0.0 -3.72384556744 0.0 0.0 -3.72989241965 0.0 0.0 -3.73832385185 0.0 0.0 -3.74779294486 0.0 0.0 -3.75249964788 0.0 0.0 -3.75613506917 0.0 0.0 -3.75860750316 0.0 0.0 -3.76641460607 0.0 0.0 -3.76691460607 0.0 0.0 -3.76741460607 0.0 0.0 -3.76818104243 0.0 0.0 -3.76970155563 0.0 0.0 -3.77265205857 0.0 0.0 -3.77826435306 0.0 0.0 -3.78826435306 0.0 0.0 -3.7901017139 0.0 0.0 -3.79836279537 0.0 0.0 -3.80836279537 0.0 0.0 -3.81639765414 0.0 0.0 -3.82472337166 0.0 0.0 -3.83472337166 0.0 0.0 -3.84391279908 0.0 0.0 -3.84969885614 0.0 0.0 -3.85617284637 0.0 0.0 -3.86476362693 0.0 0.0 -3.86892914886 0.0 0.0 -3.87472507157 0.0 0.0 -3.8840827411 0.0 0.0 -3.8940827411 0.0 0.0 -3.90342968835 0.0 0.0 -3.91142678491 0.0 0.0 -3.9163014047 0.0 0.0 -3.92062607875 0.0 0.0 -3.9217584828 0.0 0.0 -3.9317584828 0.0 0.0 -3.94154948133 0.0 0.0 -3.94961218043 0.0 0.0 -3.95145872411 0.0 0.0 -3.95822160001 0.0 0.0 -3.95950866605 0.0 0.0 -3.96912189781 0.0 0.0 -3.97912189781 0.0 0.0 -3.98912189781 0.0 0.0 -3.99397241568 0.0 0.0 -4.00397241568 0.0 0.0 -4.01397241568 0.0 0.0 -4.02352923189 0.0 0.0 -4.03108542383 0.0 0.0 -4.04098363009 0.0 0.0 -4.04826446883 0.0 0.0 -4.05826446883 0.0 0.0 -4.06697744393 0.0 0.0 -4.07287965588 0.0 0.0 -4.08287965588 0.0 0.0 -4.09287965588 0.0 0.0 -4.0958374306 0.0 0.0 -4.09878214129 0.0 0.0 -4.10779049078 0.0 0.0 -4.11779049078 0.0 0.0 -4.12779049078 0.0 0.0 -4.13779049078 0.0 0.0 -4.14630402127 0.0 0.0 -4.14750029196 0.0 0.0 -4.14945135708 0.0 0.0 -4.14995135708 0.0 0.0 -4.15045135708 0.0 0.0 -4.15330762913 4776.93315081 0.0 -4.15770386712 0.0 0.0 -4.15929198487 228.521137038 0.0 -4.15997327972 3472.0099754 0.0 -4.16049023246 4006.47470481 0.0 -4.16204941383 1419.16546087 0.0 -4.16515308767 521.585346603 0.0 -4.16671725725 993.645374911 0.0 -4.16983892155 2232.06798127 0.0 -4.17033892155 11506.8111366 0.0 -4.17088852295 10376.4802965 0.0 -4.17203203388 6116.75148571 0.0 -4.17332680718 6717.37693164 0.0 -4.1753289825 4987.36573348 0.0 -4.17839271281 2839.63165969 0.0 -4.18198744329 1554.92508753 0.0 -4.18575558352 746.74373032 0.0 -4.18857360184 -169.601241165 0.0 -4.1942865338 -111.287320232 0.0 -4.19742856834 -56.4644284275 0.0 -4.20440581459 125.545200972 0.0 -4.20791027077 637.451641919 0.0 -4.21442031419 696.391862599 0.0 -4.22111873466 815.224696658 0.0 -4.22632359818 956.414632196 0.0 -4.22937442793 1062.81716339 0.0 -4.23354899359 1067.73827678 0.0 -4.24247893804 989.027459345 0.0 -4.25226884341 945.434576192 0.0 -4.25780406459 801.197162707 1.48732200328 -4.26646670789 703.425579369 0.0 -4.27646670789 618.113023497 0.0 -4.28292562711 479.884883408 0.0 -4.28683460846 -63.8233522035 0.0 -4.28962728056 -478.789341794 13.8189287074 -4.29830791742 -362.344041965 16.0409546709 -4.30629841381 -97.8408959801 18.0682778706 -4.31629841381 215.75352996 15.7804926984 -4.32595731925 567.286815124 0.0 -4.33595731925 854.198574006 6.93381604196 -4.3451387364 1034.87518757 4.65797906733 -4.3538578168 1097.38183814 8.45943271852 -4.36087832052 1088.30194563 6.16492788281 -4.36929773911 1052.6591984 4.94878022816 -4.37822226434 998.625507901 8.2546126817 -4.38822226434 931.514826913 8.70001859596 -4.39712808536 671.470918942 7.8517839913 -4.40535956767 596.455807065 7.23624676129 -4.41104876995 510.135374958 7.74584315263 -4.41726604095 367.995908428 7.3839658671 -4.42673369141 380.811639633 0.0 -4.43673369141 413.022368883 0.0 -4.43901831744 758.613823198 0.0 -4.44306849763 878.787839596 0.0 -4.45106601578 915.315219726 0.0 -4.46102928031 922.558139021 0.0 -4.46981274848 922.577132385 0.0 -4.47704065967 925.140047832 2.55505475877 -4.48396816016 938.107136002 2.00339197472 -4.4900670882 956.368321976 1.57290677844 -4.49565905878 982.451990121 1.19283034663 -4.50177656781 992.354367208 0.0 -4.50797076301 983.261891317 0.0 -4.5112714741 965.286577069 0.0 -4.51583418418 948.023133857 0.0 -4.52060095904 935.236761986 1.13689489931 -4.52131043683 795.135455424 1.86975728064 -4.52197018244 715.146840095 1.06884597653 -4.52345141995 713.509059266 0.919282549079 -4.52436613823 716.583553347 1.05395951179 -4.52763039886 729.431726789 0.780583963268 -4.5311811718 749.994842613 0.767305024191 -4.53464943827 758.588589291 0.0 -4.53514943827 1000.32995704 0.0 -4.53961446233 992.829000797 0.0 -4.54401261441 963.662611145 0.0 -4.54808309281 902.816263737 0.0 -4.55130475431 828.578150803 0.0 -4.55490916187 809.593022071 0.0 -4.55850422035 788.200910898 0.0 -4.56326939956 751.120114241 0.0 -4.56745678564 715.119972199 0.0 -4.57177714707 701.792672922 0.0 -4.57454121928 696.891395292 0.0 -4.57966465889 672.964383845 -0.431371617038 -4.5839877769 628.01627808 -0.485456795206 -4.58990522869 596.191315116 0.0 -4.59654755202 614.195874138 0.0 -4.60440138823 588.871018932 -1.26496448574 -4.61162920622 539.381207538 0.0 -4.61454760031 431.175566777 0.0 -4.61858007698 388.938084165 0.0 -4.61964226059 394.692171992 0.0 -4.62146153962 395.815516333 0.0 -4.62361731212 412.860339702 0.0 -4.62645035117 382.634159225 0.0 -4.63041655673 428.614949254 0.0 -4.63615322968 500.323251744 0.0 -4.63924576945 484.240296213 0.0 -4.64346330853 430.08425933 0.0 -4.6478742314 476.299592506 0.0 -4.65376993163 624.126053386 0.0 -4.65730800143 720.927094295 0.0 -4.66107656233 602.807310984 0.0 -4.6651686827 437.28164217 0.0 -4.66851441079 379.592341706 0.0 -4.67372759751 365.235927677 0.0 -4.67901272294 402.893364173 0.0 -4.68361398075 595.117528484 0.0 -4.6922549991 574.510130951 0.0 -4.69445125821 481.620369826 0.0 -4.69812609139 515.745386344 0.0 -4.70406311051 482.378828819 0.0 -4.70983194947 444.841567523 0.0 -4.7187527222 428.11068762 0.0 -4.72843058412 393.306097548 0.0 -4.73802707055 383.845457415 0.0 -4.74802707055 399.423564056 0.0 -4.75513411706 406.988892602 0.0 -4.76079719623 432.968497104 0.0 -4.77079719623 427.987885124 0.0 -4.77717790382 459.823511616 0.0 -4.78427492688 461.599423499 0.0 -4.79427492688 471.439942574 0.0 -4.80427492688 467.578447965 0.0 -4.81427492688 458.378667219 0.0 -4.82374894567 450.443934252 0.0 -4.83362262687 435.001366718 0.0 -4.84362262687 418.684739359 0.0 -4.85276455283 407.326260011 0.0 -4.86276455283 403.203336313 0.0 -4.87276455283 397.08882025 0.0 -4.88276455283 387.375565671 0.0 -4.89276455283 382.16474149 0.0 -4.90276455283 375.200198278 0.0 -4.91276455283 372.274702762 0.0 -4.92276455283 361.991577755 0.0 -4.92326455283 369.431197273 0.0 -4.93031726844 371.707097362 0.0 -4.93488302008 378.260055388 0.0 -4.94133812663 358.570423145 0.0 -4.94519289692 322.56153702 0.0 -4.95332806032 296.082884207 0.0 -4.9615041257 283.46894342 0.0 -4.96610642591 278.605524557 0.0 -4.96805922329 288.625667454 0.0 -4.96982372587 298.074998932 0.0 -4.97486256414 290.465304053 0.0 -4.97855878259 278.398408141 0.0 -4.98277255922 278.697791895 0.0 -4.986698849 290.545989764 0.0 -4.99247611207 292.974973572 0.0 -4.99681031887 289.671014778 0.0 -4.99890644674 289.169811164 0.0 -5.00360128781 282.366262807 0.0 -5.01058384593 269.903046979 0.0 -5.0123135874 298.858309862 0.0 -5.0135980245 267.790755488 0.0 -5.021117134 237.748452927 0.0 -5.0247191602 217.633863405 0.0 -5.02805761323 207.046876463 0.0 -5.03344991182 199.765045238 0.0 -5.03953445209 190.214714505 0.0 -5.04157809415 191.099856484 0.0 -5.04354207005 198.837878544 0.0 -5.04720119276 194.467202121 0.0 -5.05181170495 187.52224914 0.0 -5.05764464739 176.632116894 0.0 -5.0617022858 172.586498047 0.0 -5.06723695778 162.627456913 0.0 -5.07212586161 152.747051322 0.0 -5.07691800859 129.562816116 0.0 -5.08198933848 117.643027302 0.0 -5.08345534126 90.9056143334 0.0 -5.08635235226 86.1194582341 0.0 -5.08990836761 83.7433400571 0.0 -5.09274279154 81.7036724412 0.0 -5.09593597272 74.6091711389 0.0 -5.10022673809 74.3751529921 0.0 -5.10652002088 68.3377143851 0.0 -5.11255052272 66.6335931472 0.0 -5.11798058195 60.7174553103 0.0 -5.11945990791 65.2131239276 0.0 -5.11995990791 74.6086837112 0.0 -5.12045990791 71.5765189206 0.0 -5.12106654582 72.0402151273 0.0 -5.12234063428 65.9855592493 0.0 -5.12411313976 61.6248388884 0.0 -5.12553750005 58.9070102104 0.0 -5.12685268917 54.9807883739 0.0 -5.1284754589 53.228692158 0.0 -5.1307389205 50.702368236 0.0 -5.13438162522 46.1916659668 0.0 -5.13594445348 42.2438463171 0.0 -5.13680147174 63.0545800361 0.0 -5.13984420468 47.6294152079 0.0 -5.14075547096 32.0087717888 0.0 -5.14299832253 20.4721302509 0.0 -5.14757032946 18.0481390999 0.0 -5.14959244268 23.7784354848 0.0 -5.15724448451 9.65287436405 0.0 -5.16407862841 -4.04573379187 0.0 -5.17142515561 -30.2445759181 0.0 -5.17694841384 -54.6347484678 0.0 -5.18486980058 -69.5178926843 0.0 -5.18709783961 -54.4325162237 0.0 -5.19518334564 -49.5652156869 0.0 -5.20354923205 -17.5643513874 0.0 -5.21289020486 0.0 0.0 -5.22289020486 0.0 0.0 -5.22984307127 0.0 0.0 -5.23844162505 0.0 0.0 -5.24128767112 0.0 0.0 -5.25128767112 0.0 0.0 -5.25381286565 0.0 0.0 -5.25571158341 0.0 0.0 -5.25906079012 0.0 0.0 -5.26368721187 0.0 0.0 -5.2689374374 0.0 0.0 -5.26946334426 0.0 0.0 -5.2710104735 0.0 0.0 -5.27804949685 0.0 0.0 -5.28804949685 0.0 0.0 -5.29685342413 0.0 0.0 -5.30425819235 0.0 0.0 -5.31275600623 0.0 0.0 -5.32275600623 0.0 0.0 -5.33275600623 0.0 0.0 -5.34275600623 0.0 0.0 -5.35275600623 0.0 0.0 -5.36269983954 0.0 0.0 -5.37205233801 0.0 0.0 -5.38170276246 0.0 0.0 -5.39170276246 0.0 0.0 -5.40156074672 0.0 0.0 -5.40521193477 0.0 0.0 -5.40889690548 0.0 0.0 -5.41889690548 0.0 0.0 -5.42862742836 0.0 0.0 -5.43637953917 0.0 0.0 -5.44076933713 0.0 0.0 -5.44472328754 0.0 0.0 -5.45379145554 0.0 0.0 -5.46285858522 0.0 0.0 -5.46566739976 0.0 0.0 -5.47330768911 0.0 0.0 -5.47946647307 0.0 0.0 -5.48357558193 0.0 0.0 -5.48814936822 0.0 0.0 -5.49293128926 0.0 0.0 -5.49861206922 0.0 0.0 -5.50793047822 0.0 0.0 -5.51345198264 0.0 0.0 -5.52095745685 0.0 0.0 -5.52784214888 0.0 0.0 -5.52991893941 0.0 0.0 -5.53284274475 0.0 0.0 -5.54196840705 0.0 0.0 -5.55159449596 0.0 0.0 -5.56159449596 0.0 0.0 -5.56598779283 0.0 0.0 -5.57404524825 0.0 0.0 -5.58404524825 0.0 0.0 -5.59404524825 0.0 0.0 -5.60404524825 0.0 0.0 -5.61383405054 0.0 0.0 -5.61590993223 0.0 0.0 -5.62590993223 0.0 0.0 -5.63590993223 0.0 0.0 -5.64590993223 0.0 0.0 -5.65590993223 0.0 0.0 -5.66590993223 0.0 0.0 -5.67590993223 0.0 0.0 -5.68237087978 0.0 0.0 -5.68997142091 0.0 0.0 -5.69997142091 0.0 0.0 -5.70997142091 0.0 0.0 -5.71997142091 0.0 0.0 -5.72833775913 0.0 0.0 -5.73718765984 0.0 0.0 -5.74003806411 0.0 0.0 -5.74848409742 0.0 0.0 -5.75789343821 0.0 0.0 -5.76789343821 0.0 0.0 -5.77570020379 0.0 0.0 -5.77662298371 0.0 0.0 -5.78064894649 0.0 0.0 -5.79064894649 0.0 0.0 -5.80064894649 0.0 0.0 -5.81064894649 0.0 0.0 -5.82064894649 0.0 0.0 -5.83064894649 0.0 0.0 -5.84064894649 0.0 0.0 -5.85064894649 0.0 0.0 -5.86018579606 0.0 0.0 -5.86661818882 0.0 0.0 -5.87399530226 0.0 0.0 -5.88272040461 0.0 0.0 -5.89272040461 0.0 0.0 -5.90272040461 0.0 0.0 -5.91204185416 0.0 0.0 -5.91920099006 0.0 0.0 -5.92875133042 0.0 0.0 -5.93214821774 0.0 0.0 -5.93906714407 0.0 0.0 -5.94538367123 0.0 0.0 -5.95339475879 0.0 0.0 -5.96087715805 0.0 0.0 -5.96680682254 0.0 0.0 -5.9711352499 0.0 0.0 -5.9752901555 0.0 0.0 -5.97654197625 0.0 0.0 -5.97704197625 0.0 0.0 -5.98193747835 0.0 0.0 -5.98641843489 0.0 0.0 -5.99134586386 0.0 0.0 -5.99524363893 0.0 0.0 -5.99692841429 0.0 0.0 -6.00262248682 0.0 0.0 -6.00476352255 0.0 0.0 -6.00843004428 0.0 0.0 -6.01387757194 0.0 0.0 -6.01831960337 0.0 0.0 -6.02142121971 0.0 0.0 -6.02336067022 0.0 0.0 -6.03329450564 0.0 0.0 -6.04002352031 0.0 0.0 -6.04520246259 3492.39943729 0.0 -6.05115967742 2768.90912247 0.0 -6.05165967742 8367.43231164 0.0 -6.05220285557 7079.94354053 0.0 -6.05326688186 5648.72104309 0.0 -6.05457219086 4818.95782438 0.0 -6.05624282466 4297.87776109 0.0 -6.05724664246 3599.10371022 0.0 -6.05893194799 2277.52650091 0.0 -6.06214226642 2491.46521235 0.0 -6.06441375054 1956.88323234 0.0 -6.06877828658 1719.50284809 0.0 -6.0721934223 985.903064216 0.0 -6.07382724754 251.022684394 0.0 -6.07649973507 79.7369887271 0.0 -6.07718737887 254.866701818 0.0 -6.08341282264 353.97157546 0.0 -6.08849038326 773.22024784 0.0 -6.09561233756 810.318074771 0.0 -6.09663814427 1019.88978626 0.0 -6.10178840364 1155.01448874 0.0 -6.10883607921 1128.23339408 0.0 -6.11636401212 1026.51266154 0.0 -6.12528152634 907.845048567 0.0 -6.13465455072 877.955815058 0.0 -6.14308101079 829.821602224 0.0 -6.14822762602 739.793703474 0.0 -6.15459584063 675.111725618 0.0 -6.15874933985 395.649047132 0.0 -6.16874933985 404.097082043 -0.0112071717111 -6.17157866377 269.437864892 -1.03664299664 -6.17527913904 263.354925613 0.754789389837 -6.17955321979 318.57355958 0.0 -6.18955321979 403.993115599 0.0 -6.19955321979 525.493607585 0.0 -6.20955321979 640.676324499 0.0 -6.21955321979 743.889084893 0.0 -6.22522183269 854.098767957 0.0 -6.23329308698 895.124160839 0.0 -6.24329308698 896.793071332 0.0 -6.24657022787 847.953488214 0.0 -6.24767143498 723.589196279 53.4969487654 -6.25006089725 681.375708799 0.0 -6.26006089725 690.96507821 0.0 -6.27006089725 717.642736376 0.0 -6.28006089725 749.539398809 0.0 -6.29006089725 785.311080056 0.0 -6.30006089725 803.653689092 0.0 -6.31006089725 849.354997072 0.0 -6.32006089725 886.902662707 0.0 -6.32971960373 904.961929893 24.9436636077 -6.33773327941 948.567311113 14.7361207761 -6.34523597178 985.030814937 14.6941744708 -6.35101995258 1011.59390159 12.7230215324 -6.3560414156 1033.57387387 11.6870101497 -6.36085445097 1048.15310219 0.0 -6.36623479276 1044.31870186 0.0 -6.37168346795 1034.96333622 0.0 -6.37661318102 1013.78294568 0.0 -6.38299601839 1003.64472301 -39.9577928821 -6.38919810868 971.358948011 28.2666709399 -6.39603758217 951.543976268 17.0405048029 -6.40427451184 902.355003415 -10.2082672568 -6.4114450488 880.865526434 4.77973156638 -6.41691877038 852.998043104 0.0 -6.41855728529 712.831342019 0.0 -6.42060307295 639.310054726 0.0 -6.42316245563 600.840582824 0.0 -6.42672787129 603.835662141 0.0 -6.43151601023 627.27045119 0.0 -6.43595744211 657.654855226 0.0 -6.44046872194 702.070481684 0.0 -6.44514339033 740.198413185 0.0 -6.4503387396 759.958255348 0.0 -6.45603625919 753.640040383 0.0 -6.46163878978 784.954401015 0.0 -6.46716254007 1000.27934967 0.0 -6.46888355351 1063.87089742 0.0 -6.47265254249 998.939948548 0.0 -6.47864587546 977.617965348 -0.433703426335 -6.48571674572 954.870736273 0.0 -6.48938992716 969.047520106 0.0 -6.49306120242 861.897887193 0.0 -6.50003639379 831.770560819 0.0 -6.50703131129 767.99732576 0.0 -6.51360287962 778.831174333 0.0 -6.52314234378 665.753513237 0.0 -6.52836823495 525.495131876 0.0 -6.53696167027 423.702560475 0.0 -6.54547142205 368.767525186 0.0 -6.55547142205 316.517291776 0.0 -6.55901529465 268.257269491 0.0 -6.56721745811 252.529383493 0.0 -6.57554459698 488.428133421 0.0 -6.58160948233 716.08753759 0.0 -6.58639301235 865.643319096 0.0 -6.590842366 942.774359539 0.0 -6.59640957429 894.474320471 0.0 -6.60307636345 860.116061052 0.0 -6.60527100941 618.597512183 0.0 -6.61527100941 593.676111052 0.0 -6.62527100941 568.548606462 0.0 -6.63489194872 547.606861195 0.0 -6.64489194872 530.885510883 0.0 -6.65489194872 517.144829067 0.0 -6.66306143849 496.608541728 0.0 -6.66928392328 474.137578312 0.0 -6.67511236022 457.678754029 0.0 -6.68375889624 440.914091697 0.0 -6.68877652764 416.980456669 0.0 -6.69251223484 396.51458249 0.0 -6.70099934886 389.183979482 0.0 -6.70513652823 421.012043383 0.0 -6.71292265891 448.647783083 0.0 -6.71950494348 476.896479957 0.0 -6.72737465736 505.807961931 0.0 -6.73666833766 509.882040088 0.0 -6.74666833766 513.692603697 0.0 -6.75407239353 528.21665724 0.0 -6.75998324365 528.582885927 0.0 -6.76677099335 520.055337369 0.0 -6.77319618137 509.030082155 0.0 -6.77410583313 460.286878066 0.0 -6.77547211278 432.867556394 0.0 -6.78496349815 422.218819109 0.0 -6.78990029002 438.228593427 0.0 -6.7958920153 441.610437151 0.0 -6.80076283634 451.376249454 0.0 -6.80690810227 446.988178412 0.0 -6.81430913044 446.325756608 0.0 -6.82157098049 439.664628409 0.0 -6.82508520457 435.536206078 0.0 -6.83508520457 416.586768619 0.0 -6.83998819636 399.158241064 0.0 -6.84582709626 385.18599913 0.0 -6.85249622531 372.75385646 0.0 -6.85966051998 361.683141383 0.0 -6.86612917184 353.142694826 0.0 -6.87154599838 347.959389051 0.0 -6.87385453272 348.691229101 0.0 -6.87604633051 350.889506438 0.0 -6.88548717988 338.739793854 0.0 -6.89307405987 329.424849554 0.0 -6.90088734479 317.197080788 0.0 -6.90795196896 306.975640514 0.0 -6.91270170804 303.066453156 0.0 -6.91619693833 300.352343976 0.0 -6.91992295837 294.19158671 0.0 -6.92157456247 294.297910017 0.0 -6.92609853934 283.836598855 0.0 -6.92944700998 277.224158038 0.0 -6.93063723233 274.595095601 0.0 -6.93388427123 268.581157684 0.0 -6.93814298342 258.666891494 0.0 -6.93998557944 252.084752566 0.0 -6.94574855051 227.874197142 0.0 -6.94712108271 185.420670811 0.0 -6.9509872736 194.665213477 0.0 -6.95238658546 251.514173401 0.0 -6.95608442043 240.737861141 0.0 -6.96032797928 228.058366673 0.0 -6.96167908752 208.038795966 0.0 -6.96364723162 191.128214365 0.0 -6.96566369481 184.023730619 0.0 -6.96837424042 177.569125794 0.0 -6.97172014547 167.96002085 0.0 -6.97490449356 159.072197919 0.0 -6.97662469741 154.949899028 0.0 -6.97722103506 149.732906719 0.0 -6.97851674699 147.645614761 0.0 -6.97920863243 144.742403265 0.0 -6.98055801009 142.247589657 0.0 -6.98257542523 140.495599077 0.0 -6.98528866007 136.405326759 0.0 -6.98912782666 127.976842022 0.0 -6.99452635455 118.671396821 0.0 -6.99860183815 113.998935085 0.0 -7.00286284292 109.074004318 0.0 -7.00926843978 97.103773155 0.0 -7.01414532188 87.1591699306 0.0 -7.01613870304 75.930748852 0.0 -7.01663870304 68.7931265976 0.0 -7.01794471884 70.9714232758 0.0 -7.02105815147 64.1074691157 0.0 -7.02759970925 48.0367318474 0.0 -7.03349490542 28.8747386368 0.0 -7.03868279412 19.2594826865 0.0 -7.04263914278 23.8246057906 0.0 -7.04881222941 28.2208735228 0.0 -7.05402233691 15.3579315146 0.0 -7.06153097123 5.54415578855 0.0 -7.06936730817 -1.96175500003 0.0 -7.07660135403 -8.26036145498 0.0 -7.08157420183 -30.5565165272 0.0 -7.09098765075 -44.052615221 0.0 -7.10053990708 -47.7186810569 0.0 -7.11053990708 0.0 0.0 -7.12053990708 0.0 0.0 -7.13053990708 0.0 0.0 -7.14053990708 0.0 0.0 -7.15053990708 0.0 0.0 -7.16053990708 0.0 0.0 -7.17053990708 0.0 0.0 -7.18053990708 0.0 0.0 -7.18462436231 0.0 0.0 -7.18927577602 0.0 0.0 -7.19555245256 0.0 0.0 -7.20045518888 0.0 0.0 -7.20672954264 0.0 0.0 -7.21217604399 0.0 0.0 -7.21904605218 0.0 0.0 -7.22698996608 0.0 0.0 -7.23476851841 0.0 0.0 -7.24476851841 0.0 0.0 -7.24622404915 0.0 0.0 -7.24827876208 0.0 0.0 -7.25129102299 0.0 0.0 -7.25481051041 0.0 0.0 -7.25903098077 0.0 0.0 -7.26460810982 0.0 0.0 -7.26946221388 0.0 0.0 -7.27219645772 0.0 0.0 -7.27586091464 0.0 0.0 -7.28422667257 0.0 0.0 -7.28937216725 0.0 0.0 -7.29737465638 0.0 0.0 -7.30462101275 0.0 0.0 -7.31162031442 0.0 0.0 -7.31853955881 0.0 0.0 -7.32526194074 0.0 0.0 -7.33138728206 0.0 0.0 -7.33785859751 0.0 0.0 -7.34442758444 0.0 0.0 -7.34939777819 0.0 0.0 -7.35643520008 0.0 0.0 -7.36347458008 0.0 0.0 -7.37180985338 0.0 0.0 -7.38151908489 0.0 0.0 -7.38989546079 0.0 0.0 -7.39400068082 0.0 0.0 -7.40400068082 0.0 0.0 -7.41196643631 0.0 0.0 -7.42039807782 0.0 0.0 -7.42691524825 0.0 0.0 -7.43337172299 0.0 0.0 -7.4393952002 0.0 0.0 -7.44420317489 0.0 0.0 -7.45016573807 0.0 0.0 -7.45537581754 0.0 0.0 -7.46125038069 0.0 0.0 -7.46256750625 0.0 0.0 -7.46681722043 0.0 0.0 -7.47368005108 0.0 0.0 -7.47418005108 0.0 0.0 -7.477297826 0.0 0.0 -7.47937369911 0.0 0.0 -7.48364983972 0.0 0.0 -7.48822860753 0.0 0.0 -7.49373604747 0.0 0.0 -7.50042300314 0.0 0.0 -7.50594593868 0.0 0.0 -7.51221219982 0.0 0.0 -7.51454245966 0.0 0.0 -7.51938713443 0.0 0.0 -7.52752671742 0.0 0.0 -7.53260420657 0.0 0.0 -7.53906177856 0.0 0.0 -7.5457765282 0.0 0.0 -7.5492539417 0.0 0.0 -7.55424141559 0.0 0.0 -7.56038588493 0.0 0.0 -7.57028231976 0.0 0.0 -7.58028231976 0.0 0.0 -7.58606794259 0.0 0.0 -7.58916941957 0.0 0.0 -7.58966941957 0.0 0.0 -7.59962195992 0.0 0.0 -7.60863137894 0.0 0.0 -7.61022426374 0.0 0.0 -7.6130902529 0.0 0.0 -7.61979929245 0.0 0.0 -7.62756388526 0.0 0.0 -7.6331534123 0.0 0.0 -7.6431534123 0.0 0.0 -7.6531534123 0.0 0.0 -7.6631534123 0.0 0.0 -7.6731534123 0.0 0.0 -7.6831534123 0.0 0.0 -7.69027851852 0.0 0.0 -7.69706088861 0.0 0.0 -7.70706088861 0.0 0.0 -7.71706088861 0.0 0.0 -7.72587720332 0.0 0.0 -7.73587720332 0.0 0.0 -7.74587720332 0.0 0.0 -7.75587720332 0.0 0.0 -7.76587720332 0.0 0.0 -7.77587720332 0.0 0.0 -7.78587720332 0.0 0.0 -7.79567212373 0.0 0.0 -7.80528974945 0.0 0.0 -7.80582209975 0.0 0.0 -7.81535425939 0.0 0.0 -7.81651103426 0.0 0.0 -7.81909204687 0.0 0.0 -7.82452471463 0.0 0.0 -7.83452471463 0.0 0.0 -7.83817778658 0.0 0.0 -7.84606446978 0.0 0.0 -7.84725806695 0.0 0.0 -7.84950644254 0.0 0.0 -7.8538438381 0.0 0.0 -7.86182342032 0.0 0.0 -7.86552073617 0.0 0.0 -7.87316179444 0.0 0.0 -7.87788473995 0.0 0.0 -7.88096488842 0.0 0.0 -7.88301380799 0.0 0.0 -7.8860732952 0.0 0.0 -7.88978056078 0.0 0.0 -7.89289848131 0.0 0.0 -7.89614247898 0.0 0.0 -7.90038489985 0.0 0.0 -7.90389852427 0.0 0.0 -7.90718503468 0.0 0.0 -7.91360721648 0.0 0.0 -7.91619743331 0.0 0.0 -7.92155345715 1420.29610646 0.0 -7.92657952277 3841.17147595 0.0 -7.92940719519 3780.45579991 0.0 -7.93490473851 3316.44747782 0.0 -7.93971750028 3158.35847717 0.0 -7.94036898564 3519.86433615 0.0 -7.94521448743 3462.25202818 0.0 -7.94718542166 3007.30347741 0.0 -7.94768542166 1302.45593855 0.0 -7.94939906613 1109.56735396 0.0 -7.95002693557 -754.800959683 0.0 -7.95210730841 -290.514574875 0.0 -7.95266383997 264.404046639 0.0 -7.95378983724 839.088637923 0.0 -7.95462422394 1058.50481528 0.0 -7.95720280841 801.417351108 0.0 -7.96123207082 733.267169079 0.0 -7.96564395906 851.392231772 0.0 -7.96978655291 848.73878935 0.0 -7.97494996711 798.056469251 0.0 -7.97967164287 931.090391099 0.0 -7.98066175968 1073.70791419 0.0 -7.98179302692 1298.68970564 0.0 -7.98419185521 1279.21035686 0.0 -7.98690982166 1223.96867709 0.0 -7.99019395637 1136.7779631 0.0 -7.9953670194 1013.80973125 0.0 -8.00086031031 966.685319846 0.0 -8.00385019364 697.067221023 0.0 -8.01385019364 688.726088618 0.0 -8.02385019364 686.626470358 0.0 -8.03341769492 691.636719804 0.0 -8.04088887905 668.114626095 0.0 -8.04233306337 641.104190771 0.0 -8.0454645973 536.654939548 0.0 -8.04865376337 540.751329707 0.0 -8.05500666771 575.331736607 0.0 -8.05835969681 646.634341969 0.0 -8.06361272142 702.888984611 0.0 -8.06455073317 859.877019791 0.0 -8.06594161339 901.076226515 0.0 -8.06758781512 906.956667918 0.0 -8.06998903665 888.457033755 0.0 -8.07308057083 857.272230588 324.83837114 -8.07622195197 809.741139926 0.0 -8.08064946256 773.398711158 0.0 -8.08560268029 731.492366215 0.0 -8.08989955128 690.408524078 51.1501178422 -8.09384871457 656.684063253 44.9469693292 -8.09919584706 632.747063378 42.8529554728 -8.10278770917 633.362381671 -17.1770331104 -8.1034233578 549.670659916 5.99980932126 -8.10848949464 557.27263393 4.54377066635 -8.11508229531 585.343951019 11.8552059172 -8.11984370572 632.074482222 2.77270239947 -8.12936959584 684.220826199 0.0 -8.13873291823 753.633929161 0.0 -8.14639318866 817.952987015 0.0 -8.15152177958 890.082438941 0.0 -8.1604959462 926.153981634 0.0 -8.17039797146 938.085850715 0.0 -8.17962017649 940.26141767 8.27364441255 -8.18916872032 944.553414425 11.6461825459 -8.19078299182 822.703879757 10.2646791548 -8.19156039278 650.21257159 9.17988927946 -8.19330244923 625.422542689 9.9387178045 -8.19575384657 654.225352516 7.42922328101 -8.19899549742 667.143882621 8.30760330581 -8.20312976359 704.774075555 54.0438367258 -8.20871647872 760.900591031 41.4519370104 -8.21171431046 862.923291063 8.00180227477 -8.21459114287 954.505732065 12.5284041835 -8.21509114287 1369.57141831 0.105170710526 -8.2159247929 1574.05423 0.067628216986 -8.2204900154 1561.4736866 -65.5095230195 -8.22272981637 1503.3504506 -7.79253697748 -8.22403210091 1354.29842472 -7.67329430602 -8.22612932114 1256.84563083 0.0 -8.22797986755 1116.13928922 0.0 -8.23061968362 1022.17849515 0.0 -8.23374722103 944.582033173 0.0 -8.23733214512 884.813749115 0.0 -8.24136329798 855.393969798 0.0 -8.2447957859 831.627620432 0.0 -8.25025256846 837.812768225 2.5808173372 -8.25276362816 863.985916461 2.80651159926 -8.25992315481 889.194652809 0.0 -8.26049991704 1380.64155075 0.0 -8.2616711325 1490.48957299 0.0 -8.26533837671 1470.66058322 0.0 -8.2713015364 1420.37461318 0.0 -8.27757889874 1331.83960444 0.0 -8.28581688093 1280.2072721 0.0 -8.29286253596 1196.13027974 0.0 -8.29759249068 1081.40549839 0.0 -8.30112020524 728.057055888 0.0 -8.30503898955 597.758860587 0.0 -8.3091677516 549.174839392 1.91554669053 -8.31331135802 553.86720362 1.81356908696 -8.31730902645 576.473366095 0.0 -8.32252036049 662.612917156 0.0 -8.33040931944 690.840375033 0.0 -8.33539587959 834.445054682 0.0 -8.33810213351 1013.58386725 0.0 -8.3409816355 1128.05518721 0.0 -8.34401958004 1154.68093045 0.0 -8.34818491677 1083.40676533 0.0 -8.34989324004 912.710173748 0.912443898479 -8.35177308114 870.467495729 0.564830369265 -8.35514352567 838.167990151 0.409097547902 -8.35836865718 875.8372757 0.0 -8.36208030477 812.382221757 0.0 -8.36633471179 737.463005956 0.0 -8.37295014076 701.134973153 0.0 -8.37757412437 638.450676136 0.0 -8.38168659442 576.923325616 0.0 -8.38664823772 591.386427504 0.0 -8.39167242021 598.84760882 0.0 -8.39581265666 574.301982077 0.0 -8.39696576909 602.632874821 0.0 -8.39930803094 630.317845147 0.0 -8.40390907788 626.386425947 0.0 -8.41283024241 600.112944251 0.0 -8.41531295945 599.609596789 0.0 -8.41735567678 680.284894363 0.0 -8.42153092038 779.924377813 0.0 -8.42256250444 1831.53441657 0.0 -8.42477902267 1531.16069963 0.0 -8.42727810525 1261.03311858 0.0 -8.43210205797 926.178863928 0.0 -8.43669370595 680.786737905 0.0 -8.43986569261 472.541028437 0.0 -8.44237811311 496.199286779 0.0 -8.44511818199 373.845215467 0.0 -8.4496232065 330.816920181 0.0 -8.45477017966 336.573675918 0.0 -8.45999949182 404.829480657 0.0 -8.46562505438 464.586996066 0.0 -8.47195983985 523.480820465 0.0 -8.47819011327 570.641596483 0.0 -8.48679804371 623.505804893 0.0 -8.49639263741 622.658628374 0.0 -8.50534367347 632.506560169 0.0 -8.51405388002 663.424673228 0.0 -8.52172377072 648.577977909 0.0 -8.5298483391 633.673639003 0.0 -8.53689568738 623.23856016 0.0 -8.54235275839 612.703596039 0.0 -8.54699232043 614.47622605 0.0 -8.55135899269 614.09403187 0.0 -8.55866263428 606.393590731 0.0 -8.56715583187 596.580339849 0.0 -8.57715583187 591.958897716 0.0 -8.57998677618 596.001326214 0.0 -8.58344510121 554.544209487 0.0 -8.58956326207 545.0029424 0.0 -8.59355640814 533.727436848 0.0 -8.59575707026 521.987567813 0.0 -8.60145060434 517.653284463 0.0 -8.60429355792 522.172365395 0.0 -8.61429355792 511.207130965 0.0 -8.61529195467 526.048244269 0.0 -8.61579195467 568.376284867 0.0 -8.61866490631 569.767280228 0.0 -8.62172705072 566.96798239 0.0 -8.62470784903 565.214866832 0.0 -8.62536694844 540.211291104 0.0 -8.62586694844 506.959610692 0.0 -8.62641165154 464.461805092 0.0 -8.62762521789 452.909911855 0.0 -8.62990730479 454.552568383 0.0 -8.63413420382 448.637192202 0.0 -8.6410981524 451.616501181 0.0 -8.64866781068 465.291799157 0.0 -8.65563299022 469.471942644 0.0 -8.66563299022 468.207459249 0.0 -8.67045352261 530.012331567 0.0 -8.67907945357 539.379340378 0.0 -8.68907945357 536.234443317 0.0 -8.69614606906 533.961037091 0.0 -8.70214916938 528.703445688 0.0 -8.70501085869 528.580964339 0.0 -8.70896107762 529.30674862 0.0 -8.71240006205 496.737309245 0.0 -8.71430115797 467.135040489 0.0 -8.71931698775 453.94296852 0.0 -8.72482305966 437.487546259 0.0 -8.73236425097 417.81974949 0.0 -8.73883067113 400.084513293 0.0 -8.74362395613 395.75784296 0.0 -8.75015394785 389.654243921 0.0 -8.75464605047 389.347804869 0.0 -8.75969436748 388.773494997 0.0 -8.76505344172 386.094393446 0.0 -8.77149266286 381.830405342 0.0 -8.7777286051 376.093056944 0.0 -8.78352743851 368.961623272 0.0 -8.79073527999 357.76098616 0.0 -8.79770503976 344.285390785 0.0 -8.79968588557 335.983710931 0.0 -8.8038713033 332.943398809 0.0 -8.81161860437 318.071961179 0.0 -8.81483839131 307.225925058 0.0 -8.820843924 293.364862439 0.0 -8.82586459617 282.784451005 0.0 -8.83118349376 272.407870397 0.0 -8.83538994021 264.649633492 0.0 -8.83952607917 257.982619121 0.0 -8.84083766683 259.716792462 0.0 -8.84355021758 256.922444067 0.0 -8.84811555157 246.928696122 0.0 -8.85016990713 240.351072528 0.0 -8.85154873639 252.673714511 0.0 -8.85466354487 245.471391174 0.0 -8.85898235379 236.940025014 0.0 -8.86275145527 231.341246759 0.0 -8.86831496754 223.206892146 0.0 -8.86883183477 240.924515606 0.0 -8.87007721632 232.673798665 0.0 -8.87217971794 217.741806974 0.0 -8.87476607882 202.450545074 0.0 -8.87891470285 199.155739419 0.0 -8.88409505475 187.990708852 0.0 -8.88534350624 145.323983817 0.0 -8.88982939169 169.901482119 0.0 -8.89572908599 148.85319309 0.0 -8.89726513956 125.051537357 0.0 -8.89899352756 195.957160799 0.0 -8.90048995588 82.831016137 0.0 -8.90253283367 89.0633451489 0.0 -8.90543803036 148.553084513 0.0 -8.90900947366 95.8766922565 0.0 -8.90950947366 -71.0314975498 0.0 -8.91000947366 219.498690584 0.0 -8.91050947366 -69.6800271922 0.0 -8.91100947366 213.568702031 0.0 -8.91150947366 94.1839118946 0.0 -8.91200947366 254.75806461 0.0 -8.91264340033 189.560389408 0.0 -8.91332384065 180.620999693 0.0 -8.91409408298 140.611201215 0.0 -8.914980589 199.972749807 0.0 -8.91585201915 128.470983922 0.0 -8.91647696273 122.464299945 0.0 -8.91733024715 145.260466848 0.0 -8.91830207955 57.4843120073 0.0 -8.91882674887 157.387649511 0.0 -8.9195101369 108.861124397 0.0 -8.9203849448 112.944578411 0.0 -8.92166613219 118.875627221 0.0 -8.92261000355 125.650132498 0.0 -8.92385845067 144.802025283 0.0 -8.92535010882 102.860123712 0.0 -8.92694511452 86.9202659709 0.0 -8.92834111821 95.0301766034 0.0 -8.92994613601 90.9618497507 0.0 -8.93044613601 48.8471875013 0.0 -8.93096704116 59.5823279316 0.0 -8.93202461828 63.9292357576 0.0 -8.93397406807 59.1908632156 0.0 -8.93562883966 65.4379141271 0.0 -8.93785593041 52.1618505867 0.0 -8.94020433343 43.8547038587 0.0 -8.94256473408 62.4876241374 0.0 -8.94517143206 66.9009785492 0.0 -8.94781015327 56.2905033694 0.0 -8.95101511616 62.0430208022 0.0 -8.95394971647 86.7045591134 0.0 -8.95680375733 56.4080986389 0.0 -8.95981977789 86.7587405114 0.0 -8.96250486756 102.853609713 0.0 -8.96473430154 -25.415929948 0.0 -8.96813692052 -20.2259478391 0.0 -8.97148648434 19.944233277 0.0 -8.97644752811 53.3906191477 0.0 -8.97943931579 60.160406951 0.0 -8.98393072678 67.2877206371 0.0 -8.99022404274 119.876131122 0.0 -8.992560581 115.708320263 0.0 -8.99409263516 173.997037717 0.0 -8.99459263516 164.057939593 0.0 -8.99509263516 136.633619283 0.0 -8.99583275714 111.856707755 0.0 -8.99734550578 91.2901103353 0.0 -9.0003508545 68.725317923 0.0 -9.00443067736 27.2199385847 0.0 -9.00860287317 24.4513301505 0.0 -9.01209598669 46.99194453 0.0 -9.01474852124 52.7173556219 0.0 -9.01816056217 47.6526636527 0.0 -9.02244668172 35.9000455341 0.0 -9.0254630299 30.4026859611 0.0 -9.02821024555 23.1523110887 0.0 -9.031645877 8.41020676609 0.0 -9.03527554197 13.2011288666 0.0 -9.03577554197 48.5670663548 0.0 -9.03657319009 35.013915806 0.0 -9.03859323153 20.3912831954 0.0 -9.04172972556 14.6505026702 0.0 -9.0429509303 18.2644632853 0.0 -9.04417465085 12.0723544146 0.0 -9.04594822692 -3.40355034562 0.0 -9.05072168157 -5.82543661175 0.0 -9.05158491441 46.7355549015 0.0 -9.05209125932 -54.057333565 0.0 -9.05260493128 -42.4098427321 0.0 -9.05327170754 -8.22910951258 0.0 -9.05420720762 -24.064731884 0.0 -9.05576115345 17.668098672 0.0 -9.05822198011 31.3233559446 0.0 -9.06029392984 18.4667973406 0.0 -9.06185175013 21.4114439952 0.0 -9.06298674421 -114.456876684 0.0 -9.06543048165 -87.8742821385 0.0 -9.06950119649 -35.0461669604 0.0 -9.07227718564 0.0 0.0 -9.07774910243 0.0 0.0 -9.0824685612 0.0 0.0 -9.08576443845 0.0 0.0 -9.09081727821 0.0 0.0 -9.09755752633 0.0 0.0 -9.1012197922 0.0 0.0 -9.10736213647 0.0 0.0 -9.11078764587 0.0 0.0 -9.11608111513 0.0 0.0 -9.12481967447 0.0 0.0 -9.12806032358 0.0 0.0 -9.13332455905 0.0 0.0 -9.13876625849 0.0 0.0 -9.14216983499 0.0 0.0 -9.1444635602 0.0 0.0 -9.14766708019 0.0 0.0 -9.15158157123 0.0 0.0 -9.15580956097 0.0 0.0 -9.15630956097 0.0 0.0 -9.15723505458 0.0 0.0 -9.15911446117 0.0 0.0 -9.16297446855 0.0 0.0 -9.1695869988 0.0 0.0 -9.1731561885 0.0 0.0 -9.18035322776 0.0 0.0 -9.18445488433 0.0 0.0 -9.19117741817 0.0 0.0 -9.19434181111 0.0 0.0 -9.19952960205 0.0 0.0 -9.20325906041 0.0 0.0 -9.2073180699 0.0 0.0 -9.208509589 0.0 0.0 -9.21074164261 0.0 0.0 -9.2165164557 0.0 0.0 -9.21787851897 0.0 0.0 -9.21938594533 0.0 0.0 -9.22118199319 0.0 0.0 -9.22367601673 0.0 0.0 -9.22665055445 0.0 0.0 -9.22967326693 0.0 0.0 -9.23017326693 0.0 0.0 -9.23067326693 0.0 0.0 -9.23420490527 0.0 0.0 -9.23747991983 0.0 0.0 -9.24267054338 0.0 0.0 -9.2485574645 0.0 0.0 -9.25502617196 0.0 0.0 -9.25768930841 0.0 0.0 -9.26084781348 0.0 0.0 -9.2629182918 0.0 0.0 -9.26725619631 0.0 0.0 -9.27120528708 0.0 0.0 -9.27694988033 0.0 0.0 -9.27790904208 0.0 0.0 -9.27898613272 0.0 0.0 -9.28109376481 0.0 0.0 -9.2828002489 0.0 0.0 -9.28421069088 0.0 0.0 -9.28733233487 0.0 0.0 -9.29115131398 0.0 0.0 -9.29493304144 0.0 0.0 -9.30002770313 0.0 0.0 -9.30247135359 0.0 0.0 -9.30483142882 0.0 0.0 -9.30914641696 0.0 0.0 -9.31490641707 0.0 0.0 -9.31979756154 0.0 0.0 -9.32319396066 0.0 0.0 -9.32626403487 0.0 0.0 -9.32890557169 0.0 0.0 -9.33036463035 0.0 0.0 -9.3329037669 0.0 0.0 -9.33620762175 0.0 0.0 -9.33807792363 0.0 0.0 -9.33857792363 0.0 0.0 -9.34084380097 0.0 0.0 -9.34395575557 0.0 0.0 -9.34662837548 0.0 0.0 -9.34922679499 0.0 0.0 -9.35284512978 0.0 0.0 -9.35385121317 0.0 0.0 -9.3563724542 0.0 0.0 -9.35929369265 0.0 0.0 -9.36229002962 0.0 0.0 -9.36587488972 0.0 0.0 -9.37037865109 0.0 0.0 -9.37655566236 0.0 0.0 -9.38063373745 0.0 0.0 -9.38189605673 0.0 0.0 -9.38364034063 0.0 0.0 -9.38724606933 0.0 0.0 -9.39120447444 0.0 0.0 -9.39837683402 0.0 0.0 -9.40141565621 0.0 0.0 -9.40328738715 0.0 0.0 -9.4056004788 0.0 0.0 -9.40816657826 0.0 0.0 -9.41227847873 0.0 0.0 -9.41744033722 0.0 0.0 -9.42491882624 0.0 0.0 -9.43217324469 0.0 0.0 -9.44037934555 0.0 0.0 -9.44087934555 0.0 0.0 -9.44191062391 0.0 0.0 -9.4459574804 0.0 0.0 -9.45031238271 0.0 0.0 -9.45390794349 0.0 0.0 -9.45855493247 0.0 0.0 -9.46099114494 0.0 0.0 -9.46429467821 0.0 0.0 -9.46479467821 0.0 0.0 -9.46617489716 0.0 0.0 -9.46813940731 0.0 0.0 -9.47010149161 0.0 0.0 -9.47267380358 0.0 0.0 -9.47691237874 0.0 0.0 -9.48216838901 0.0 0.0 -9.4854250098 0.0 0.0 -9.49408935445 0.0 0.0 -9.49458935445 0.0 0.0 -9.49541317565 0.0 0.0 -9.4964629034 0.0 0.0 -9.49755148564 0.0 0.0 -9.498883068 0.0 0.0 -9.50044910219 0.0 0.0 -9.50226286393 0.0 0.0 -9.5043707449 0.0 0.0 -9.50676560824 0.0 0.0 -9.50954241551 0.0 0.0 -9.51282514756 0.0 0.0 -9.51677552993 0.0 0.0 -9.5216202923 0.0 0.0 -9.52640002638 0.0 0.0 -9.53307829056 0.0 0.0 -9.54161013198 0.0 0.0 -9.54526705764 0.0 0.0 -9.55043395837 0.0 0.0 -9.56043395837 0.0 0.0 -9.57043395837 0.0 0.0 -9.57974092093 0.0 0.0 -9.58367002571 0.0 0.0 -9.58665632295 0.0 0.0 -9.58858607195 0.0 0.0 -9.59128610094 0.0 0.0 -9.59800020506 0.0 0.0 -9.60591226259 0.0 0.0 -9.60862347515 0.0 0.0 -9.61254519138 0.0 0.0 -9.62063669 0.0 0.0 -9.62755096192 0.0 0.0 -9.63465505842 0.0 0.0 -9.64006583322 0.0 0.0 -9.64126565457 0.0 0.0 -9.64326703089 0.0 0.0 -9.64620071359 0.0 0.0 -9.65160966901 0.0 0.0 -9.66160966901 0.0 0.0 -9.67160966901 0.0 0.0 -9.68160966901 0.0 0.0 -9.68671204144 0.0 0.0 -9.6903776867 0.0 0.0 -9.69775484969 0.0 0.0 -9.70372039532 0.0 0.0 -9.71343560822 0.0 0.0 -9.72343560822 0.0 0.0 -9.72902919848 0.0 0.0 -9.73229514256 0.0 0.0 -9.73815768332 0.0 0.0 -9.74106718784 0.0 0.0 -9.74679944253 0.0 0.0 -9.75679944253 0.0 0.0 -9.76623476426 0.0 0.0 -9.77293267152 0.0 0.0 -9.78271651677 0.0 0.0 -9.79269214607 0.0 0.0 -9.79915590753 0.0 0.0 -9.80234753496 0.0 0.0 -9.80947537217 662.720020862 0.0 -9.81036792322 3331.4706281 0.0 -9.81130845161 1624.42367714 0.0 -9.81252451359 1120.97151507 0.0 -9.81303407691 3346.99584883 0.0 -9.8156942507 2686.10075724 0.0 -9.81782475182 4098.21310578 0.0 -9.82481633439 3727.54944303 0.0 -9.82977737055 3383.82365455 0.0 -9.83429456431 1819.23212755 0.0 -9.83641135582 1581.2494103 0.0 -9.83974803365 1497.53968414 0.0 -9.84297031775 1283.52215835 0.0 -9.84654333472 1298.03647395 0.0 -9.84969711199 1243.71358078 0.0 -9.85311200261 1171.06743646 0.0 -9.85627556561 1094.66940209 0.0 -9.86049325927 1081.97679944 0.0 -9.86437002203 1056.31083259 0.0 -9.86928137875 1032.85757477 0.0 -9.87471531427 1029.10399117 0.0 -9.88020858079 1046.12329029 2.17432777049 -9.88585745947 1047.56766388 6.26637484827 -9.89210400348 1022.64549974 0.0 -9.89813334929 990.878493342 -39.5777451198 -9.90364599707 944.158210866 78.5842224584 -9.90966675913 927.713638588 28.0566453927 -9.91563807773 866.105333784 21.0028593579 -9.92181755228 822.109409947 -10.993365358 -9.92784994863 772.695492017 38.5470163048 -9.93647568579 773.83699027 25.3471455463 -9.93697568579 -95.6839593979 532.874523164 -9.93747568579 -417.719534964 -204.891329001 -9.93803877294 -442.493368359 -87.0586765125 -9.93885047714 -312.869428787 -76.5759583053 -9.93959785078 -93.7554780309 -64.4026562882 -9.94067011426 103.464950969 -52.2045012694 -9.94154452449 337.22191274 -11.3250080257 -9.94214216936 656.999772445 31.3925939276 -9.94295381296 873.348723517 37.0697421469 -9.94385320883 1057.85548588 30.5582294155 -9.94482854073 1183.50639993 26.2461834716 -9.94556120999 1290.9283139 9.10731532749 -9.94648634953 1332.10023829 14.0165887932 -9.94775550402 1318.65795546 55.521213531 -9.94922260106 1269.02390377 45.1448510954 -9.95011578389 1163.51346299 23.5446952176 -9.95165922104 1093.69211853 23.1224956706 -9.95327265049 1003.52313026 31.6054662484 -9.95496640997 915.394799926 13.4354934974 -9.95578123402 748.621530219 -18.5322432086 -9.95693058358 643.923554802 -6.34869156569 -9.95819500535 571.765977479 0.217498001832 -9.95960178763 525.308260673 5.14716044023 -9.96182385007 515.441218707 -10.2176391174 -9.96447137684 524.327085141 -18.8124741351 -9.96725070372 553.405622933 14.1943556071 -9.97004630726 591.050963939 6.49001901378 -9.97342233405 634.195988593 10.8318838255 -9.97676968802 679.553437853 17.4605556429 -9.98105241434 721.672683454 11.4375535465 -9.98340304044 777.341302025 16.573405018 -9.98785736614 800.755374533 13.96276526 -9.9930967508 817.154341382 14.7075782384 -9.99898915899 823.814661438 13.7261746165 -9.99976906813 811.635784887 14.7205169527 -10.0012143124 809.919572567 38.7347206189 -10.0032052534 811.492230299 9.19516327942 -10.005632663 814.614468496 16.967765899 -10.0087115548 818.536975732 25.4522341696 -10.0132506719 823.221551693 17.6253699731 -10.017175038 823.790364037 8.38554237826 -10.0212825018 824.626787462 5.88948663282 -10.0257774016 821.476100692 -4.33643842785 -10.0298197936 819.802227699 20.3037876115 -10.0353248177 820.984946916 16.4762988805 -10.0408050646 824.988649217 19.8890228591 -10.0459605227 830.414896753 25.0298695937 -10.0522166682 839.375327286 22.5189848629 -10.0532931817 867.251065789 28.9301555769 -10.0632931817 873.915851737 20.3078574231 -10.0732931817 909.575988274 11.3352952103 -10.0804934918 952.728516277 12.4358662109 -10.0897412584 974.50145892 18.9607862885 -10.0944579761 1009.41397644 9.60712568164 -10.0996962471 1040.17898768 17.2622631332 -10.1080993527 1065.21384278 13.7233229895 -10.1165627755 1146.6849794 -1.42877036516 -10.1244416482 1225.51266378 13.2127837829 -10.1315046574 1289.64216494 -6.0860797246 -10.1384964984 1335.47755593 7.20430928837 -10.1449605502 1350.96729747 3.37436038731 -10.1509964096 1345.91580215 0.0661957544891 -10.1534386518 1318.34085038 2.56891340864 -10.1582228674 1301.58309449 -6.0670031961 -10.1630461848 1291.47004318 0.0 -10.1663330443 1260.13208812 0.0 -10.1704678156 1244.02944634 0.0 -10.1746274398 1232.20042869 -1.53824398789 -10.1801818017 1233.15919573 0.0592265737666 -10.1856879895 1240.82502142 0.951089375331 -10.191051567 1254.17017847 5.41653020212 -10.1958367064 1256.33132142 1.94681334439 -10.2007604449 1282.74585153 0.0 -10.2050544602 1274.13545529 0.0 -10.2093176719 1286.15939626 0.0 -10.2140400496 1281.34504832 0.0 -10.2179439181 1281.05980915 0.0 -10.2226227482 1270.34754949 0.0 -10.2273538847 1238.08816604 0.0 -10.2324810678 1201.81885111 0.0 -10.2371119461 1161.93128077 0.0 -10.241113163 1129.92247505 0.368623836059 -10.2450602987 1087.08340603 0.236024567167 -10.2490967538 1044.82513308 0.0 -10.2535225953 1022.08543504 0.0 -10.2582185234 1075.49005753 0.0 -10.263133491 1050.83551604 0.0 -10.2668481592 1102.30314913 0.0 -10.2704745216 1044.67342633 0.0 -10.2738629139 1088.91863809 0.0 -10.276605043 998.175693233 0.0 -10.2806038503 903.256850515 0.0 -10.2860182858 854.900764225 0.0 -10.2887343958 860.298460058 0.0 -10.2917004163 792.029737644 0.0 -10.2939970151 586.627519017 0.0 -10.2981894748 563.992319451 0.0 -10.3026781816 546.054783384 0.0 -10.3072402499 620.084664258 0.0 -10.3102128704 1029.63920237 0.0 -10.3139948554 680.012674002 0.0 -10.314596245 -485.761445374 0.0 -10.3173480764 441.249237931 0.0 -10.3227963198 378.217179698 0.0 -10.3276351466 357.884177744 0.0 -10.3328557578 249.758859363 0.0 -10.337057514 424.876158296 0.0 -10.342136522 414.140110528 0.0 -10.3489407277 379.522300856 0.0 -10.3566759464 430.56808106 0.0 -10.3641609146 662.763698051 0.0 -10.3678802993 825.014541498 0.0 -10.3744239453 880.658774815 0.0 -10.3829018788 793.589000058 0.0 -10.3848875431 436.125942471 0.0 -10.3901065552 421.243094229 0.0 -10.3960633756 416.087192073 0.0 -10.3998940784 506.000403379 0.0 -10.4098940784 478.89351863 0.0 -10.4134704304 666.102139289 0.0 -10.4216015893 686.67398554 0.0 -10.4288103309 702.040120306 0.0 -10.4322686949 679.91450978 0.0 -10.4377857736 726.391829669 0.0 -10.442022032 659.426323988 0.0 -10.447463192 686.034682469 0.0 -10.4531705501 670.659637108 0.0 -10.4585070096 679.205575821 0.0 -10.4602246326 671.907347691 0.0 -10.460850033 690.51750346 0.0 -10.4658043313 655.240213084 0.0 -10.4705794245 648.856416528 0.0 -10.4753544724 637.539436566 0.0 -10.4789411194 588.14769795 0.0 -10.4810218869 573.992634215 0.0 -10.4820096474 566.812378666 0.0 -10.4825096474 530.742425016 0.0 -10.4867212372 529.502566506 0.0 -10.489042856 539.810748526 0.0 -10.4899860385 535.983298253 0.0 -10.492693122 572.575432701 0.0 -10.4965166955 578.38847566 0.0 -10.4975419591 567.869048811 0.0 -10.500701409 581.150536769 0.0 -10.5017338439 572.08247971 0.0 -10.5027569757 576.267370403 0.0 -10.5089383152 569.515760756 0.0 -10.5137974875 570.988137812 0.0 -10.5172520968 564.649302997 0.0 -10.5206486538 545.177486771 0.0 -10.5232766671 526.251849344 0.0 -10.5268734021 511.079272326 0.0 -10.5296652402 501.912364941 0.0 -10.5331859591 494.662061891 0.0 -10.5364514122 488.805012371 0.0 -10.5405759098 488.605843943 0.0 -10.5437885835 487.234026769 0.0 -10.5468620719 491.94887954 0.0 -10.5502783691 497.27226566 0.0 -10.5555701493 495.19972683 0.0 -10.557969393 500.332607884 0.0 -10.5613059906 499.815992455 0.0 -10.5645862291 495.893439475 0.0 -10.5704863238 487.114231581 0.0 -10.5784219496 478.962462169 0.0 -10.5842535199 475.037823116 0.0 -10.5888442973 458.229304539 0.0 -10.5958811372 447.466740511 0.0 -10.6038014286 449.272354517 0.0 -10.6108974633 453.272998949 0.0 -10.6184479723 435.704284587 0.0 -10.6284479723 427.202594062 0.0 -10.6310609324 29152.9697352 0.0 -10.6315609324 -14465.3175343 0.0 -10.6320609324 -1311041.32221 0.0 -10.6325609324 -1267862.651 0.0 -10.6330609324 0.0 0.0 diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history1.csv b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history1.csv deleted file mode 100644 index ca9d9b418f7a..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history1.csv +++ /dev/null @@ -1,2943 +0,0 @@ -time (0.0,0.093) (0.0,0.299) -1e-06 0.0 0.0 -2e-06 0.0 0.0 -3e-06 0.0 0.0 -0.010003 5.86025287745 0.0 -0.020003 26.4141166395 0.0 -0.030003 40.0917737712 0.0 -0.040003 66.5511766812 0.0 -0.050003 71.2917384868 0.0 -0.060003 78.3111310933 0.0 -0.070003 80.4027722871 0.0 -0.080003 83.5881874101 0.0 -0.090003 83.8050538669 0.0 -0.100003 85.3755285639 0.0 -0.110003 88.0694035307 0.0 -0.120003 88.4026918048 0.0 -0.130003 89.8396821616 0.0 -0.140003 92.7208626367 0.0 -0.150003 96.803946937 0.0 -0.160003 101.544198551 0.0 -0.170003 107.426293739 0.0 -0.180003 113.231927924 0.0 -0.190003 117.973521422 0.0 -0.200003 123.846969752 0.0 -0.209923389554 124.085840557 0.0 -0.219923389554 127.154309805 0.0 -0.229923389554 135.159028905 0.0 -0.239923389554 136.9417468 0.0 -0.249923389554 138.258560556 0.0 -0.259923389554 140.002699371 0.0 -0.269923389554 142.531569625 0.0 -0.279923389554 144.467584816 0.0 -0.289923389554 146.454610595 0.0 -0.299923389554 148.874753749 0.0 -0.309923389554 151.834451155 0.0 -0.319923389554 155.270783363 0.0 -0.329923389554 158.807414607 0.0 -0.335948326478 161.08365465 0.0 -0.345948326478 164.758528307 0.0 -0.355948326478 168.359547615 0.0 -0.365948326478 171.507557371 0.0 -0.375948326478 174.594676601 0.0 -0.385948326478 177.686375318 0.0 -0.395948326478 183.014787244 0.0 -0.405948326478 187.309470908 0.0 -0.415948326478 192.196859646 0.0 -0.425948326478 192.147929801 0.0 -0.435948326478 191.443054941 0.0 -0.445948326478 192.786156717 0.0 -0.455948326478 195.856067396 0.0 -0.465948326478 194.304828875 0.0 -0.475948326478 199.860567332 0.0 -0.485948326478 206.255551241 0.0 -0.495948326478 218.349290754 0.0 -0.505948326478 221.618882499 0.0 -0.515948326478 230.493852415 0.0 -0.525948326478 237.308672194 0.0 -0.535948326478 242.727117729 0.0 -0.545948326478 233.360776148 0.0 -0.555948326478 248.514128409 0.0 -0.565948326478 252.004018113 0.0 -0.575948326478 257.516259327 0.0 -0.585948326478 262.69006234 0.0 -0.595948326478 267.246645494 0.0 -0.605948326478 271.962976938 0.0 -0.615948326478 276.160262435 0.0 -0.625948326478 279.920797976 0.0 -0.635948326478 284.093106262 0.0 -0.645948326478 287.058019477 0.0 -0.655948326478 289.470293228 0.0 -0.665948326478 291.443056022 0.0 -0.675948326478 287.30661315 0.0 -0.685948326478 291.359914713 0.0 -0.695948326478 292.50241341 0.0 -0.705948326478 293.857046738 0.0 -0.715948326478 295.023083118 0.0 -0.725948326478 295.780413012 0.0 -0.730028290128 296.002330427 0.0 -0.740028290128 296.551344266 0.0 -0.750028290128 291.741680448 0.0 -0.760028290128 295.614699023 0.0 -0.770028290128 294.986787009 0.0 -0.780028290128 295.201373665 0.0 -0.790028290128 292.578210411 0.0 -0.800028290128 294.92989793 0.0 -0.810028290128 296.116244725 0.0 -0.820028290128 296.901544614 0.0 -0.830028290128 297.22009028 0.0 -0.840028290128 287.202533931 0.0 -0.850028290128 290.528640623 0.0 -0.860028290128 288.024871865 0.0 -0.870028290128 285.824577182 0.0 -0.880028290128 269.685351407 0.0 -0.890028290128 276.24793928 0.0 -0.900028290128 275.897609977 0.0 -0.910028290128 274.356655989 0.0 -0.920028290128 272.736619798 0.0 -0.930028290128 270.703880266 0.0 -0.940028290128 267.874973967 0.0 -0.950028290128 259.355701863 0.0 -0.954134036299 261.2985907 0.0 -0.964134036299 248.009881254 0.0 -0.974134036299 246.701117546 0.0 -0.984134036299 238.901698133 0.0 -0.994134036299 232.758369358 0.0 -1.0041340363 226.402260945 0.0 -1.0141340363 212.186059197 0.0 -1.0241340363 211.940448196 0.0 -1.0341340363 206.198503991 0.0 -1.0441340363 201.148123649 0.0 -1.0541340363 187.094151386 0.0 -1.0641340363 181.251403459 0.0 -1.0741340363 174.826113939 0.0 -1.0841340363 157.790683544 0.0 -1.0941340363 155.012745815 0.0 -1.1041340363 134.294704172 0.0 -1.1141340363 135.580592888 0.0 -1.1241340363 119.999902274 0.0 -1.1341340363 127.664551191 0.0 -1.1441340363 121.568897218 0.0 -1.1541340363 89.2281959183 0.0 -1.1641340363 103.476623344 0.0 -1.1741340363 94.2233531558 0.0 -1.1841340363 91.0358146791 0.0 -1.1941340363 82.8724713909 0.0 -1.2041340363 75.1047954034 0.0 -1.2141340363 70.6763051415 0.0 -1.2241340363 64.5150267941 0.0 -1.2341340363 54.4522580467 0.0 -1.2441340363 30.200767536 0.0 -1.2541340363 13.2816433317 0.0 -1.2641340363 -5.80022312882 0.0 -1.2741340363 -4.10332440736 0.0 -1.2841340363 -6.85762814843 0.0 -1.2941340363 -39.2587629144 0.0 -1.30181661616 -49.8886538379 0.0 -1.31181661616 -39.3753207503 0.0 -1.32181661616 -26.4809107415 0.0 -1.33181661616 -21.5207208273 0.0 -1.34181661616 0.0 0.0 -1.35181661616 0.0 0.0 -1.36181661616 0.0 0.0 -1.37181661616 0.0 0.0 -1.38181661616 0.0 0.0 -1.39181661616 0.0 0.0 -1.40181661616 0.0 0.0 -1.41181661616 0.0 0.0 -1.42181661616 0.0 0.0 -1.43181661616 0.0 0.0 -1.44181661616 0.0 0.0 -1.45181661616 0.0 0.0 -1.46157666674 0.0 0.0 -1.46317785082 0.0 0.0 -1.47317785082 0.0 0.0 -1.48317785082 0.0 0.0 -1.49317785082 0.0 0.0 -1.50317785082 0.0 0.0 -1.51317785082 0.0 0.0 -1.52317785082 0.0 0.0 -1.53317785082 0.0 0.0 -1.54317785082 0.0 0.0 -1.55317785082 0.0 0.0 -1.56317785082 0.0 0.0 -1.57317785082 0.0 0.0 -1.58317785082 0.0 0.0 -1.59317785082 0.0 0.0 -1.60317785082 0.0 0.0 -1.61317785082 0.0 0.0 -1.62317785082 0.0 0.0 -1.63317785082 0.0 0.0 -1.64317785082 0.0 0.0 -1.65317785082 0.0 0.0 -1.66317785082 0.0 0.0 -1.67317785082 0.0 0.0 -1.68317785082 0.0 0.0 -1.69317785082 0.0 0.0 -1.70317785082 0.0 0.0 -1.71317785082 0.0 0.0 -1.72317785082 0.0 0.0 -1.73317785082 0.0 0.0 -1.74317785082 0.0 0.0 -1.75317785082 0.0 0.0 -1.76317785082 0.0 0.0 -1.77317785082 0.0 0.0 -1.78317785082 0.0 0.0 -1.79317785082 0.0 0.0 -1.80317785082 0.0 0.0 -1.81317785082 0.0 0.0 -1.81982619246 0.0 0.0 -1.82982619246 0.0 0.0 -1.83982619246 0.0 0.0 -1.84982619246 0.0 0.0 -1.85982619246 0.0 0.0 -1.86982619246 0.0 0.0 -1.87982619246 0.0 0.0 -1.88982619246 0.0 0.0 -1.89982619246 0.0 0.0 -1.90982619246 0.0 0.0 -1.91982619246 0.0 0.0 -1.92982619246 0.0 0.0 -1.93982619246 0.0 0.0 -1.94982619246 0.0 0.0 -1.95982619246 0.0 0.0 -1.96982619246 0.0 0.0 -1.97982619246 0.0 0.0 -1.98982619246 0.0 0.0 -1.99982619246 0.0 0.0 -2.00982619246 0.0 0.0 -2.01982619246 0.0 0.0 -2.02982619246 0.0 0.0 -2.03982619246 0.0 0.0 -2.04982619246 0.0 0.0 -2.05173148418 0.0 0.0 -2.05666662096 0.0 0.0 -2.06666662096 0.0 0.0 -2.07666662096 0.0 0.0 -2.08666662096 0.0 0.0 -2.09666662096 0.0 0.0 -2.10666662096 0.0 0.0 -2.11442018734 0.0 0.0 -2.11535459836 0.0 0.0 -2.12535459836 0.0 0.0 -2.13535459836 0.0 0.0 -2.14535459836 0.0 0.0 -2.15535459836 0.0 0.0 -2.16535459836 0.0 0.0 -2.17535459836 0.0 0.0 -2.18535459836 0.0 0.0 -2.19535459836 0.0 0.0 -2.20535459836 0.0 0.0 -2.21535459836 0.0 0.0 -2.22299265041 0.0 0.0 -2.23299265041 0.0 0.0 -2.24299265041 0.0 0.0 -2.24904145542 0.0 0.0 -2.25904145542 0.0 0.0 -2.26904145542 0.0 0.0 -2.27752879866 0.0 0.0 -2.28752879866 0.0 0.0 -2.29752879866 0.0 0.0 -2.30731758317 0.0 0.0 -2.31731758317 0.0 0.0 -2.32296802631 0.0 0.0 -2.32470909667 0.0 0.0 -2.32752322354 81.397384099 0.0 -2.33308778271 16.8406125255 0.0 -2.3426614513 239.70376014 0.0 -2.3526614513 408.022915308 0.0 -2.36122657212 601.208427201 0.0 -2.37122657212 683.921091898 0.0 -2.38122657212 757.060438596 0.0 -2.38336886826 1083.80273189 0.0 -2.38597370043 1054.06277756 0.0 -2.38913514727 1027.40681094 0.0 -2.39397220158 968.352452981 0.0 -2.39892061585 858.088570478 0.0 -2.40560117539 786.150669387 0.0 -2.41297769507 708.555755926 0.0 -2.42064058344 648.781434182 0.0 -2.42644794444 579.557430112 0.0 -2.43623090431 574.503409618 0.0 -2.44444213154 573.571589001 0.0 -2.4521501428 586.41044164 0.0 -2.4621501428 611.219337414 0.0 -2.4721501428 635.594355376 0.0 -2.4821501428 656.622789426 0.0 -2.4921501428 671.464942036 0.0 -2.5021501428 683.179406894 0.0 -2.5121501428 692.4062783 0.0 -2.5221501428 701.355397623 0.0 -2.5321501428 710.31105639 0.0 -2.5421501428 719.829521854 0.0 -2.54542263943 713.731349791 0.0 -2.54592263943 669.265022693 0.0 -2.5467989013 657.010425171 0.0 -2.54848820952 662.327332771 0.0 -2.55185138234 677.22242854 0.0 -2.55944679456 703.79939594 0.0 -2.56944679456 739.525061528 0.0 -2.57944679456 777.918225964 0.0 -2.58944679456 825.545219796 0.0 -2.59181008559 939.80658822 0.0 -2.60133830718 951.602155306 0.0 -2.60963363942 953.280280561 0.0 -2.61963363942 936.837437075 0.0 -2.62963363942 917.154097767 0.0 -2.63963363942 890.580618306 0.0 -2.64559008395 862.306098426 0.0 -2.65559008395 846.927614454 0.0 -2.66559008395 843.379709351 0.0 -2.67505651785 832.537669515 0.0 -2.67932915327 846.168193005 0.0 -2.68598343149 831.461845211 0.0 -2.69515975055 831.34045545 0.0 -2.70515975055 812.387998833 0.0 -2.71271506491 795.283818608 0.0 -2.72271506491 762.069393019 0.0 -2.73271506491 723.82450064 0.0 -2.74239171767 681.356646277 0.0 -2.74602097184 627.321608862 0.0 -2.75531491159 594.220563663 0.0 -2.76404864384 568.49746627 0.0 -2.7667028254 544.482384724 0.0 -2.77547717764 525.211473787 0.0 -2.78106363909 516.444235912 0.0 -2.79106363909 502.947087783 0.0 -2.80106363909 492.488398531 0.0 -2.80441000108 502.119814086 0.0 -2.80826978878 500.642915668 0.0 -2.81826978878 483.92354046 0.0 -2.82826978878 466.686230095 0.0 -2.83380854157 458.459328644 0.0 -2.8351705156 451.511490873 0.0 -2.8451705156 439.314219707 0.0 -2.8551705156 426.214409313 0.0 -2.8651705156 402.116696265 0.0 -2.8751705156 402.583053006 0.0 -2.88409929568 400.525204348 0.0 -2.89409929568 400.597979131 0.0 -2.90409929568 399.393600729 0.0 -2.91409929568 398.310009117 0.0 -2.92409929568 393.112368264 0.0 -2.93409929568 386.213774909 0.0 -2.94409929568 377.18968482 0.0 -2.95409929568 362.834268171 0.0 -2.96409929568 351.070807745 0.0 -2.97409929568 340.259623721 0.0 -2.97664860833 326.376567762 0.0 -2.98424824087 317.001804703 0.0 -2.98811449385 313.097116436 0.0 -2.99170357827 307.514758508 0.0 -2.99491297619 303.096224075 0.0 -2.99886797327 300.145328275 0.0 -3.00196883166 298.466527469 0.0 -3.00545133941 295.15836533 0.0 -3.00947726711 290.370697199 0.0 -3.01312246426 288.917080912 0.0 -3.01794570841 282.523014114 0.0 -3.02214490208 279.225176 0.0 -3.02563440082 261.90353526 0.0 -3.02842315412 261.001223058 0.0 -3.03032919115 264.079099492 0.0 -3.03293243577 268.441285612 0.0 -3.03372835757 284.562858718 0.0 -3.03422835757 299.985974256 0.0 -3.03472835757 308.670158753 0.0 -3.03690475736 303.30720752 0.0 -3.03971914571 295.634587952 0.0 -3.04423240794 291.192189425 0.0 -3.0481466037 278.017034969 0.0 -3.05267065386 264.551036117 0.0 -3.05662308903 251.934095213 0.0 -3.05983668301 242.504926862 0.0 -3.06366966817 235.822904168 0.0 -3.06874250567 227.303394517 0.0 -3.0720085788 221.435329284 0.0 -3.07643370122 215.238715941 0.0 -3.08241396831 205.097481521 0.0 -3.08882493258 196.260802882 0.0 -3.09145699095 194.400975245 0.0 -3.09451034909 193.849551302 0.0 -3.09787848758 191.003606725 0.0 -3.1016195776 190.411515176 0.0 -3.10516296232 186.011469993 0.0 -3.10880878895 184.928036263 0.0 -3.11674183553 175.41983748 0.0 -3.12503580373 160.666657091 0.0 -3.12996267078 150.964280366 0.0 -3.13513367169 129.104924917 0.0 -3.14149054222 113.303492308 0.0 -3.14727309517 101.798831279 0.0 -3.14964431171 90.1147746397 0.0 -3.15388791846 82.5885994069 0.0 -3.15931766083 76.9155076707 0.0 -3.16217057363 84.504609721 0.0 -3.16504958357 75.4961138947 0.0 -3.16739391361 65.287152549 0.0 -3.16895978485 58.7728078265 0.0 -3.16959585773 53.5842474525 0.0 -3.17327264626 4.68320261519 0.0 -3.17623266015 0.764044074045 0.0 -3.17704510474 -9.01855736021 0.0 -3.17981686439 4.01793578469 0.0 -3.18178925099 22.3697932884 0.0 -3.1859258196 28.5444266543 0.0 -3.1896521673 34.4367660399 0.0 -3.19166163418 41.1248767937 0.0 -3.19424618687 42.2992701317 0.0 -3.19511906108 91.4978173965 0.0 -3.19891341836 55.6344340732 0.0 -3.20064703299 53.7902267218 0.0 -3.20609783398 25.0952291603 0.0 -3.20964085548 14.1298955458 0.0 -3.21256459777 1.84644587516 0.0 -3.21599517063 -8.27806700371 0.0 -3.21990913028 -7.7315181995 0.0 -3.22104664961 -3.3348972601 0.0 -3.22520856861 -10.2776514011 0.0 -3.23047673859 -13.1987702107 0.0 -3.23263282034 -6.19404238046 0.0 -3.23545407273 -6.85601613784 0.0 -3.24002807267 -11.6312958587 0.0 -3.24530005695 -14.749792725 0.0 -3.25000108693 -10.3255052193 0.0 -3.25594603223 -6.87844492283 0.0 -3.26242104906 -22.1581452092 0.0 -3.2684239129 -28.7233306703 0.0 -3.27603062969 -30.5451795965 0.0 -3.28343780681 -68.3305136102 0.0 -3.2910835379 -75.6843686034 0.0 -3.29837499505 0.0 0.0 -3.3061840428 0.0 0.0 -3.31314891131 0.0 0.0 -3.31981923754 0.0 0.0 -3.32935210702 0.0 0.0 -3.33818592851 0.0 0.0 -3.34818592851 0.0 0.0 -3.35800172669 0.0 0.0 -3.36800172669 0.0 0.0 -3.37800172669 0.0 0.0 -3.38800172669 0.0 0.0 -3.39800172669 0.0 0.0 -3.40800172669 0.0 0.0 -3.41800172669 0.0 0.0 -3.42800172669 0.0 0.0 -3.4372579245 0.0 0.0 -3.44655121798 0.0 0.0 -3.45655121798 0.0 0.0 -3.46655121798 0.0 0.0 -3.47615956588 0.0 0.0 -3.48566852563 0.0 0.0 -3.49038287881 0.0 0.0 -3.4976504019 0.0 0.0 -3.50533445163 0.0 0.0 -3.5148253439 0.0 0.0 -3.5248253439 0.0 0.0 -3.53133430876 0.0 0.0 -3.53575544075 0.0 0.0 -3.54575544075 0.0 0.0 -3.5545497013 0.0 0.0 -3.55526395202 0.0 0.0 -3.55576395202 0.0 0.0 -3.56339250701 0.0 0.0 -3.57111288938 0.0 0.0 -3.58041667923 0.0 0.0 -3.58581540705 0.0 0.0 -3.591903997 0.0 0.0 -3.59693811443 0.0 0.0 -3.60112680805 0.0 0.0 -3.60849441185 0.0 0.0 -3.61579819336 0.0 0.0 -3.61633722914 0.0 0.0 -3.61683722914 0.0 0.0 -3.62259128697 0.0 0.0 -3.62447159039 0.0 0.0 -3.62939783533 0.0 0.0 -3.63423658082 0.0 0.0 -3.64106336497 0.0 0.0 -3.64770213136 0.0 0.0 -3.65460421971 0.0 0.0 -3.66146628639 0.0 0.0 -3.66659761879 0.0 0.0 -3.67354330934 0.0 0.0 -3.67759767982 0.0 0.0 -3.68558819108 0.0 0.0 -3.69558819108 0.0 0.0 -3.70415394685 0.0 0.0 -3.71256953743 0.0 0.0 -3.72018662374 0.0 0.0 -3.72690928021 0.0 0.0 -3.73326359025 0.0 0.0 -3.74326359025 0.0 0.0 -3.75207312257 0.0 0.0 -3.76207312257 0.0 0.0 -3.77084650581 0.0 0.0 -3.78084650581 0.0 0.0 -3.79084650581 0.0 0.0 -3.80084650581 0.0 0.0 -3.80391992404 0.0 0.0 -3.80685363495 0.0 0.0 -3.81560748797 0.0 0.0 -3.81943002717 0.0 0.0 -3.82943002717 0.0 0.0 -3.83943002717 0.0 0.0 -3.84943002717 0.0 0.0 -3.85433175653 0.0 0.0 -3.86433175653 0.0 0.0 -3.87433175653 0.0 0.0 -3.88433175653 0.0 0.0 -3.89433175653 0.0 0.0 -3.90433175653 0.0 0.0 -3.91433175653 0.0 0.0 -3.92433175653 0.0 0.0 -3.93433175653 0.0 0.0 -3.94433175653 0.0 0.0 -3.95189356035 0.0 0.0 -3.96189356035 0.0 0.0 -3.97189356035 0.0 0.0 -3.98189356035 0.0 0.0 -3.99189356035 0.0 0.0 -4.00180221401 0.0 0.0 -4.01034265673 0.0 0.0 -4.02016090047 0.0 0.0 -4.0281206959 0.0 0.0 -4.0381206959 0.0 0.0 -4.0481206959 0.0 0.0 -4.0575831807 0.0 0.0 -4.05940897706 0.0 0.0 -4.06200659397 0.0 0.0 -4.06557379472 0.0 0.0 -4.07523826283 0.0 0.0 -4.08523826283 0.0 0.0 -4.09523826283 0.0 0.0 -4.10523826283 0.0 0.0 -4.11495393913 0.0 0.0 -4.12495393913 0.0 0.0 -4.13495393913 0.0 0.0 -4.14259792282 0.0 0.0 -4.15171662092 0.0 0.0 -4.16083610453 0.0 0.0 -4.17083610453 0.0 0.0 -4.18045913415 0.0 0.0 -4.18163512277 0.0 0.0 -4.18343079257 8049.49314032 0.0 -4.18572491048 6774.96906569 0.0 -4.18893418108 5405.93229506 0.0 -4.19217322188 3550.64987539 0.0 -4.19730763855 1965.66809129 0.0 -4.20188241171 1120.32254791 0.0 -4.20698769929 487.404721206 0.0 -4.21368186947 257.700692169 0.0 -4.22046982674 309.53285474 0.0 -4.22711594042 514.647591099 0.0 -4.23307989002 736.856639882 0.0 -4.23992941738 854.267228568 0.0 -4.24819419688 898.026524078 0.0 -4.25368766739 871.176116078 0.0 -4.26237832437 845.309672341 0.0 -4.27088952499 801.269121628 -31.2433022319 -4.28088952499 759.795461202 0.0 -4.28410264805 590.089762709 0.0 -4.28922880817 539.890255274 0.0 -4.29646261336 550.074569071 -15.3793607291 -4.30576262139 587.596895991 0.0 -4.31471228772 632.265982753 0.0 -4.32279655514 674.281600026 19.7156088216 -4.33249219557 699.483172082 0.0 -4.34249219557 717.735436894 22.6871911329 -4.35249219557 730.616207757 11.8518770605 -4.36249219557 734.660917507 15.8005943061 -4.37249219557 741.044043301 16.5150866737 -4.38249219557 739.202529422 7.65559807497 -4.38809869372 714.244794594 9.05210276639 -4.38880799254 556.057696629 7.09466941713 -4.39880799254 570.791119877 7.9782352522 -4.40233061472 613.253556802 6.01980764208 -4.40844653968 657.411978739 6.24857916433 -4.41264275863 720.808874874 -6.20596102096 -4.41851159466 778.09918876 5.41172740474 -4.41901159466 1227.05431891 11.6089643181 -4.41951159466 1464.13772812 9.70509899028 -4.42001159466 1618.83431357 4.91892396798 -4.42051159466 1703.2350155 0.202130925214 -4.42101159466 1722.19378251 -1.47099010773 -4.42151159466 1684.96893715 3.80455632366 -4.42344736859 1618.77998836 4.46877265595 -4.42856571904 1538.62063532 4.53414518247 -4.43037343409 1276.26975703 5.64759456601 -4.43325770925 1088.24016336 -6.29997235418 -4.43712174228 942.401583446 1.86370827713 -4.44279677138 829.431109776 -5.1170581106 -4.44935130514 738.174070035 0.0 -4.45582140809 658.743991517 0.0 -4.46379125995 627.356713975 0.0 -4.46963230399 611.344943918 0.0 -4.47208849419 604.624045051 0.0 -4.47760613514 639.002858433 0.0 -4.486068033 708.178210366 0.0 -4.4946985398 807.320120977 0.0 -4.50257857526 925.421800405 0.0 -4.5047388321 1228.92057482 0.0 -4.50815446658 1346.37453467 0.0 -4.51102226388 1407.48683632 0.0 -4.5174016767 1379.1508764 0.0 -4.52322118136 1292.33415175 52.4405920101 -4.52828410952 1165.92814261 30.4488359 -4.53216895148 1003.08807597 53.539784546 -4.53630942188 866.367506541 33.7826023122 -4.54146224293 780.704358638 25.7595030725 -4.54435270854 686.954302446 48.6039943634 -4.54910691606 677.009659531 0.0 -4.55326142729 697.680280454 0.0 -4.55859291872 746.472429832 0.0 -4.56398290424 800.26464451 0.0 -4.56987698193 845.475565945 0.0 -4.57555850078 865.88645438 0.0 -4.58144112713 875.237049208 10.7831311282 -4.58662360249 852.990771068 13.283545541 -4.59153055334 850.729827205 14.0495335768 -4.59558282717 777.443809903 10.5479566009 -4.6004474393 719.518914382 18.442983627 -4.60510207578 656.705316201 -27.1648024481 -4.60938320332 573.345371082 0.0 -4.61356400139 538.050715309 0.0 -4.61785764188 489.157818772 0.0 -4.62186516255 471.63339106 0.0 -4.62624523116 442.200372939 0.0 -4.62813437698 371.909582735 0.0 -4.63090819301 472.64039414 0.0 -4.63805058645 452.986787243 0.0 -4.6468111673 638.585380014 0.0 -4.65353815019 548.864946965 0.0 -4.65974968579 477.363630234 0.0 -4.66029512881 329.179148767 0.0 -4.66092246218 518.178727618 0.0 -4.6666711676 538.281741413 0.0 -4.6695547791 482.673822934 0.0 -4.67616839324 444.618355618 -0.890358618205 -4.67955086585 370.6121586 -0.0410317272981 -4.68299702002 517.418202085 0.0 -4.68630506656 449.918916026 0.0 -4.68904281904 402.601727128 0.0 -4.69205097275 382.555746145 0.0 -4.69588642707 491.729749635 0.0 -4.70036472536 356.123211663 0.0 -4.70482810742 570.333687369 0.0 -4.70830329445 662.927807212 0.0 -4.70965122129 519.477404309 0.0 -4.71548418902 446.683300985 0.0 -4.72111299082 510.00899084 0.0 -4.72516922992 429.79974548 0.0 -4.7264746854 424.504747633 0.0 -4.73065494723 397.809205182 0.0 -4.73481680505 426.235199481 0.0 -4.73872665207 418.444196288 0.0 -4.74362985839 291.876577633 0.0 -4.74502181114 217.889068052 0.0 -4.7484841316 254.537419748 0.0 -4.75087496211 418.621644074 0.0 -4.75561077929 379.070493636 0.0 -4.75771043748 403.246855821 0.0 -4.76051317402 645.825807132 0.0 -4.76340834779 597.456522982 0.0 -4.76765011802 596.983781464 0.0 -4.77499417756 531.860362691 0.0 -4.77834443913 432.225951669 0.0 -4.77893554395 108.572659554 0.0 -4.78619962919 170.268935057 0.0 -4.79480135197 239.727377379 0.0 -4.80242647746 313.042125286 0.0 -4.81072456098 394.171223753 0.0 -4.81760916871 496.996286638 0.0 -4.8218429174 576.585681876 0.0 -4.82795298856 559.252667637 0.0 -4.83224903099 551.752863183 0.0 -4.83777083371 510.417658174 0.0 -4.84217270828 465.064071856 0.0 -4.8458394711 420.514798056 0.0 -4.84968499099 378.601554294 0.0 -4.85968499099 363.539033779 0.0 -4.86894421278 379.168787672 0.0 -4.87228742473 354.504149604 0.0 -4.87487939575 343.471573125 0.0 -4.87537939575 330.006160581 0.0 -4.88537939575 338.405373702 0.0 -4.88614764554 391.948627296 0.0 -4.89614764554 386.99935334 0.0 -4.90440978098 379.955981305 0.0 -4.91007168225 382.95590972 0.0 -4.92007168225 379.909900204 0.0 -4.92145988003 382.469598779 0.0 -4.92893721065 380.67617166 0.0 -4.93355348098 376.421948478 0.0 -4.93762560756 348.6370204 0.0 -4.93991701032 349.591695314 0.0 -4.9416293059 351.25527348 0.0 -4.94335310529 346.827935349 0.0 -4.94509434992 342.156303687 0.0 -4.9473319712 336.545066606 0.0 -4.95124648429 332.189236288 0.0 -4.95189910336 325.613978695 0.0 -4.95620855214 317.383350558 0.0 -4.9612301961 309.560199085 0.0 -4.96197769474 310.016550914 0.0 -4.96247769474 314.557806383 0.0 -4.96297769474 321.665215439 0.0 -4.96492475803 321.96185059 0.0 -4.96939006427 312.182515076 0.0 -4.9739917668 298.07821376 0.0 -4.9792413416 277.522664754 0.0 -4.98364447834 264.450688648 0.0 -4.98741876416 246.422148475 0.0 -4.99167833916 237.373927996 0.0 -4.99494194258 218.376465336 0.0 -4.99839775144 209.270983806 0.0 -5.00429427073 203.112522445 0.0 -5.00761626652 197.902720168 0.0 -5.01095377343 192.849664557 0.0 -5.01429376872 199.170914845 0.0 -5.01837537429 202.839302495 0.0 -5.02367116938 181.525999001 0.0 -5.02972715657 183.924558711 0.0 -5.03706965434 170.36323603 0.0 -5.04207080495 162.023658688 0.0 -5.04612958401 161.67215333 0.0 -5.05238590115 151.619272558 0.0 -5.05702723098 141.881228333 0.0 -5.06319249231 116.696042592 0.0 -5.0687858751 115.016672968 0.0 -5.07083051844 117.893266348 0.0 -5.07298962813 120.875390521 0.0 -5.07588142978 121.355406234 0.0 -5.08009329635 110.348945743 0.0 -5.08439889574 103.24993368 0.0 -5.08881305395 100.931814285 0.0 -5.09475613633 94.9261630747 0.0 -5.0996978762 91.1532285741 0.0 -5.10483112021 85.7369015794 0.0 -5.11173986843 69.9539099131 0.0 -5.11770919547 60.1907276392 0.0 -5.12381981897 51.8719105178 0.0 -5.12839126901 49.6729934705 0.0 -5.13369770438 38.0573093186 0.0 -5.13736060484 40.2592750552 0.0 -5.1408482883 18.3367835269 0.0 -5.14472341117 6.37887513211 0.0 -5.14866157903 7.91460974346 0.0 -5.15272561548 6.54387183917 0.0 -5.1570135721 1.30711170275 0.0 -5.16165019894 -1.08028237306 0.0 -5.16663627862 -4.24651280719 0.0 -5.17211304004 -14.9483775208 0.0 -5.17815178913 -29.9750484502 0.0 -5.18511195417 -26.7007099155 0.0 -5.19252094977 -30.5239348424 0.0 -5.20104789937 -42.8153133951 0.0 -5.20303379809 -38.8883311812 0.0 -5.2108094009 -51.8724291388 0.0 -5.21883234111 0.0 0.0 -5.22404064421 0.0 0.0 -5.23404064421 0.0 0.0 -5.24404064421 0.0 0.0 -5.25404064421 0.0 0.0 -5.26404064421 0.0 0.0 -5.27404064421 0.0 0.0 -5.28404064421 0.0 0.0 -5.29404064421 0.0 0.0 -5.30404064421 0.0 0.0 -5.31404064421 0.0 0.0 -5.32404064421 0.0 0.0 -5.33404064421 0.0 0.0 -5.339236745 0.0 0.0 -5.3417217736 0.0 0.0 -5.35163365013 0.0 0.0 -5.36163365013 0.0 0.0 -5.37102391487 0.0 0.0 -5.38032260894 0.0 0.0 -5.39032260894 0.0 0.0 -5.39266333367 0.0 0.0 -5.39663454692 0.0 0.0 -5.4040288422 0.0 0.0 -5.41163134403 0.0 0.0 -5.4167277795 0.0 0.0 -5.42146151736 0.0 0.0 -5.42648939219 0.0 0.0 -5.43046183627 0.0 0.0 -5.43448927314 0.0 0.0 -5.44000656155 0.0 0.0 -5.44588334352 0.0 0.0 -5.45355968488 0.0 0.0 -5.46175256137 0.0 0.0 -5.47083614748 0.0 0.0 -5.47943791464 0.0 0.0 -5.48884220844 0.0 0.0 -5.49595511473 0.0 0.0 -5.50587428517 0.0 0.0 -5.51124286112 0.0 0.0 -5.52105910671 0.0 0.0 -5.52790225741 0.0 0.0 -5.53350604622 0.0 0.0 -5.53803789201 0.0 0.0 -5.54190564619 0.0 0.0 -5.54577973765 0.0 0.0 -5.54964989053 0.0 0.0 -5.55341507819 0.0 0.0 -5.559496174 0.0 0.0 -5.56627209174 0.0 0.0 -5.57266887757 0.0 0.0 -5.57734915276 0.0 0.0 -5.5805611216 0.0 0.0 -5.58157811768 0.0 0.0 -5.58383358901 0.0 0.0 -5.58664941818 0.0 0.0 -5.58794197015 0.0 0.0 -5.58844197015 0.0 0.0 -5.59119298887 0.0 0.0 -5.59253462137 0.0 0.0 -5.59303462137 0.0 0.0 -5.59353462137 0.0 0.0 -5.59446817571 0.0 0.0 -5.59657475876 0.0 0.0 -5.60035708537 0.0 0.0 -5.60085708537 0.0 0.0 -5.60152971111 0.0 0.0 -5.60285095652 0.0 0.0 -5.60552375525 0.0 0.0 -5.60886520693 0.0 0.0 -5.61336890091 0.0 0.0 -5.62020854513 0.0 0.0 -5.62479563732 0.0 0.0 -5.6331647462 0.0 0.0 -5.63899556261 0.0 0.0 -5.64612827677 0.0 0.0 -5.65158517695 0.0 0.0 -5.6547607034 0.0 0.0 -5.65900124153 0.0 0.0 -5.66344766162 0.0 0.0 -5.66814329469 0.0 0.0 -5.67294303271 0.0 0.0 -5.67759438687 0.0 0.0 -5.68339352482 0.0 0.0 -5.68834238092 0.0 0.0 -5.69480089656 0.0 0.0 -5.70296352901 0.0 0.0 -5.70619755102 0.0 0.0 -5.70736892942 0.0 0.0 -5.71356521359 0.0 0.0 -5.71725479743 0.0 0.0 -5.72571261614 0.0 0.0 -5.73571261614 0.0 0.0 -5.74123226728 0.0 0.0 -5.74237024509 0.0 0.0 -5.74458805753 0.0 0.0 -5.75458805753 0.0 0.0 -5.7582354794 0.0 0.0 -5.76377084413 0.0 0.0 -5.76782177576 0.0 0.0 -5.77668033213 0.0 0.0 -5.78159742535 0.0 0.0 -5.78228757175 0.0 0.0 -5.7910392648 0.0 0.0 -5.79782363029 0.0 0.0 -5.8020684426 0.0 0.0 -5.8111368111 0.0 0.0 -5.81622211075 0.0 0.0 -5.82622211075 0.0 0.0 -5.83345320491 0.0 0.0 -5.84345320491 0.0 0.0 -5.8483666366 0.0 0.0 -5.8533334836 0.0 0.0 -5.8633334836 0.0 0.0 -5.86508370669 0.0 0.0 -5.87508370669 0.0 0.0 -5.88508370669 0.0 0.0 -5.89494313514 0.0 0.0 -5.9020055439 0.0 0.0 -5.90770459217 0.0 0.0 -5.91373022813 0.0 0.0 -5.91798994031 0.0 0.0 -5.92198106207 0.0 0.0 -5.92456604038 0.0 0.0 -5.92840349597 0.0 0.0 -5.93037116638 0.0 0.0 -5.93857572658 0.0 0.0 -5.94068330103 0.0 0.0 -5.94564511967 0.0 0.0 -5.95268912202 0.0 0.0 -5.96195991125 0.0 0.0 -5.96806283919 0.0 0.0 -5.97366769401 0.0 0.0 -5.97762505819 0.0 0.0 -5.98157800685 0.0 0.0 -5.98554613969 0.0 0.0 -5.99139789241 0.0 0.0 -5.99978249912 0.0 0.0 -6.00415597273 0.0 0.0 -6.00697270749 0.0 0.0 -6.01115717826 0.0 0.0 -6.01527499101 0.0 0.0 -6.0186054926 0.0 0.0 -6.02084620996 0.0 0.0 -6.02419600969 0.0 0.0 -6.02580655003 0.0 0.0 -6.0274291159 0.0 0.0 -6.02969191784 0.0 0.0 -6.03186561412 3370.51747097 0.0 -6.03597987739 2722.54898958 0.0 -6.03923444002 3875.83322824 0.0 -6.04360052324 2873.60714748 0.0 -6.04689754199 3184.63021841 0.0 -6.04955676453 2139.48376649 0.0 -6.05384436305 1872.46595445 0.0 -6.05888338729 1358.98166498 0.0 -6.06431684479 1046.37221246 0.0 -6.07077393707 657.142526501 0.0 -6.07733657532 685.87274255 0.0 -6.0847135033 602.473017009 0.0 -6.09072044734 606.758487499 0.0 -6.09618423514 608.778947038 0.0 -6.10168233663 644.051964221 0.0 -6.107710599 655.712558855 0.0 -6.11389092862 653.029645844 2.92310532262 -6.12028623334 655.124026827 0.0 -6.12694385177 660.393487411 45.1143569211 -6.13386424531 668.085453516 40.2597196719 -6.14106623187 667.036544264 0.0 -6.14876901133 666.423720796 0.0 -6.15653005604 664.330563743 0.0 -6.16460415567 655.806809096 0.0 -6.17294192015 669.667774867 0.0 -6.181521007 671.444694681 0.0 -6.19044818973 679.430085667 0.0 -6.19997931889 680.140173431 7.06102780568 -6.20997931889 679.978654183 5.57730503901 -6.21997931889 682.32886527 0.0 -6.22997931889 690.584764002 0.0 -6.23997931889 698.869539828 0.0 -6.24997931889 709.724601186 40.6329183624 -6.25997931889 726.665494436 0.0 -6.26788912419 744.836816797 0.0 -6.27788912419 765.782209896 0.0 -6.28788912419 791.708232419 0.0 -6.29252602444 832.91022789 0.0 -6.29516035906 871.432716666 0.0 -6.30516035906 877.960187706 0.0 -6.31516035906 891.478561209 0.0 -6.32516035906 907.666413077 3.14001601971 -6.33119928757 928.648708758 3.10098618901 -6.33836186704 947.847960297 0.0 -6.34762630581 965.154955274 0.0 -6.35699880337 982.16099752 0.0 -6.36518710989 994.135173701 0.0 -6.37277801928 1005.61682441 0.0 -6.37947391139 1014.49595273 0.0 -6.38584888371 1012.81706481 0.0 -6.39147011456 1004.34817044 0.0 -6.39669431864 990.412676213 0.0 -6.40226166589 971.86884279 0.0 -6.40838943522 942.901051312 0.0 -6.41597637861 913.836882039 1.41015326235 -6.42466015024 888.406664647 0.0 -6.43466015024 873.157606669 0.0 -6.44248067298 821.585774669 0.0 -6.45110181449 797.194984006 0.0 -6.46100543388 718.290151269 1.39431961601 -6.47100543388 675.243638325 0.0 -6.48010420165 588.292441872 0.0 -6.48852296902 650.164567768 0.0 -6.49316360508 638.417608266 0.0 -6.50316360508 553.088539195 0.0 -6.5118413128 513.725571735 0.0 -6.51694820611 466.811332511 0.0 -6.51988107915 437.476298666 0.0 -6.52331212542 514.237212508 0.0 -6.53049913955 579.97650412 0.0 -6.53577731033 583.65797672 0.0 -6.5390365055 997.141726343 0.0 -6.54667584739 827.992370163 0.0 -6.55221601352 609.568256294 0.0 -6.55344993007 752.324612757 0.0 -6.55684506563 733.570678345 0.0 -6.56047673191 608.400264884 0.0 -6.56524996361 555.265384427 0.0 -6.57125538056 468.014150038 0.0 -6.57530012102 405.022966198 0.0 -6.58530012102 360.877247322 0.0 -6.59530012102 376.322955758 0.0 -6.60443966719 394.048497784 0.0 -6.61244345183 453.684519209 0.0 -6.62242640673 471.151657646 0.0 -6.63242640673 505.484950722 0.0 -6.64242640673 586.031140631 0.0 -6.64884318868 588.26856607 0.0 -6.65210430403 625.480771582 0.0 -6.6610479938 605.588528512 0.0 -6.6710479938 560.419220369 0.0 -6.6810479938 546.129069211 0.0 -6.68346812161 457.400568606 0.0 -6.68975460975 443.926234581 0.0 -6.69975460975 445.608952393 0.0 -6.70372082634 468.575230734 0.0 -6.70815611422 485.222254109 0.0 -6.71815611422 501.012438745 0.0 -6.72457409211 516.140268553 0.0 -6.72671002599 555.806507391 0.0 -6.72721002599 608.964932891 0.0 -6.73721002599 593.081674627 0.0 -6.74721002599 545.299413308 0.0 -6.75721002599 499.907893191 0.0 -6.76721002599 452.014495792 0.0 -6.77721002599 425.235877523 0.0 -6.7847473379 398.332055543 0.0 -6.79017848609 381.66660496 0.0 -6.79551334381 377.33192974 0.0 -6.80054058336 384.579201235 0.0 -6.80467779179 393.877934333 0.0 -6.80848021676 409.228463726 0.0 -6.81466408187 417.8165387 0.0 -6.82264507658 417.352469369 0.0 -6.82893217609 419.797622574 0.0 -6.83431797586 421.346883033 0.0 -6.83846655993 421.627554437 0.0 -6.84153580734 423.779947633 0.0 -6.84654347401 417.656398022 0.0 -6.85189122039 407.908581921 0.0 -6.85677527234 394.514570342 0.0 -6.86153255155 379.192151117 0.0 -6.86613529528 367.548361061 0.0 -6.87164541928 354.665556194 0.0 -6.87604859061 344.61221509 0.0 -6.87932167473 334.927092654 0.0 -6.88445138222 325.225241422 0.0 -6.88911370765 315.306895143 0.0 -6.89479773249 308.145313668 0.0 -6.89841109989 308.195971045 0.0 -6.90465174058 290.856277076 0.0 -6.91027145865 291.024167235 0.0 -6.91356237847 287.003414907 0.0 -6.91799340599 267.03920578 0.0 -6.9196456255 270.206507299 0.0 -6.92508952359 270.049580146 0.0 -6.93353124228 263.558381434 0.0 -6.93670950925 254.343783744 0.0 -6.94149787238 243.926220741 0.0 -6.94495387876 235.606149022 0.0 -6.94891404412 214.155861437 0.0 -6.95328720423 217.616781704 0.0 -6.95841647784 203.747347018 0.0 -6.961907227 181.510126749 0.0 -6.96653761562 176.700168133 0.0 -6.97035942003 173.832674565 0.0 -6.97394593391 177.077912093 0.0 -6.97823232196 167.509498121 0.0 -6.98418128514 150.459640708 0.0 -6.98864019476 138.487915204 0.0 -6.99385422314 130.087723959 0.0 -6.99950499381 121.677109625 0.0 -7.00585286276 111.214003469 0.0 -7.01105070018 100.065148038 0.0 -7.01732502171 87.7022433239 0.0 -7.025578386 75.1078596357 0.0 -7.02682177119 76.6101342943 0.0 -7.02853972974 76.6624912893 0.0 -7.02908044835 74.3144655983 0.0 -7.03644894258 64.6648786981 0.0 -7.04427737441 56.3261355385 0.0 -7.05157376357 20.650731783 0.0 -7.05906880958 5.81762243347 0.0 -7.06848404627 26.4815880797 0.0 -7.07848404627 -24.9694871335 0.0 -7.08569091252 -41.5084727086 0.0 -7.09481277389 -12.5146305117 0.0 -7.10481277389 -52.5537890784 0.0 -7.11481277389 -78.9896676086 0.0 -7.12481277389 0.0 0.0 -7.13481277389 0.0 0.0 -7.14481277389 0.0 0.0 -7.15481277389 0.0 0.0 -7.16333239188 0.0 0.0 -7.17333239188 0.0 0.0 -7.18333239188 0.0 0.0 -7.19333239188 0.0 0.0 -7.20333239188 0.0 0.0 -7.21333239188 0.0 0.0 -7.22333239188 0.0 0.0 -7.23333239188 0.0 0.0 -7.23724087212 0.0 0.0 -7.23774087212 0.0 0.0 -7.23982683537 0.0 0.0 -7.24032683537 0.0 0.0 -7.24082683537 0.0 0.0 -7.24132683537 0.0 0.0 -7.25132683537 0.0 0.0 -7.25909426066 0.0 0.0 -7.25959426066 0.0 0.0 -7.26009426066 0.0 0.0 -7.2645497455 0.0 0.0 -7.2673979797 0.0 0.0 -7.27317647295 0.0 0.0 -7.27622078453 0.0 0.0 -7.27693324796 0.0 0.0 -7.2777656131 0.0 0.0 -7.27914033517 0.0 0.0 -7.28080787733 0.0 0.0 -7.2819031759 0.0 0.0 -7.28786056355 0.0 0.0 -7.29617193649 0.0 0.0 -7.30617193649 0.0 0.0 -7.31495891335 0.0 0.0 -7.32458768862 0.0 0.0 -7.33260506661 0.0 0.0 -7.33702000097 0.0 0.0 -7.34256043156 0.0 0.0 -7.34793090715 0.0 0.0 -7.35234492426 0.0 0.0 -7.35881713171 0.0 0.0 -7.36493464536 0.0 0.0 -7.37044722348 0.0 0.0 -7.37637834168 0.0 0.0 -7.38328490286 0.0 0.0 -7.38760656833 0.0 0.0 -7.39354085913 0.0 0.0 -7.40205313073 0.0 0.0 -7.40310009711 0.0 0.0 -7.40659255171 0.0 0.0 -7.40975089363 0.0 0.0 -7.41322792429 0.0 0.0 -7.41684368644 0.0 0.0 -7.42176113939 0.0 0.0 -7.42935350229 0.0 0.0 -7.43935350229 0.0 0.0 -7.44935350229 0.0 0.0 -7.45935350229 0.0 0.0 -7.46935350229 0.0 0.0 -7.47840881216 0.0 0.0 -7.48693531648 0.0 0.0 -7.49371418485 0.0 0.0 -7.49792297564 0.0 0.0 -7.50075630924 0.0 0.0 -7.50880216989 0.0 0.0 -7.51772925779 0.0 0.0 -7.52450848576 0.0 0.0 -7.53166324641 0.0 0.0 -7.53678950709 0.0 0.0 -7.54281565772 0.0 0.0 -7.5456820216 0.0 0.0 -7.55395914874 0.0 0.0 -7.55876746471 0.0 0.0 -7.56800639445 0.0 0.0 -7.57800639445 0.0 0.0 -7.58800639445 0.0 0.0 -7.59800639445 0.0 0.0 -7.59994962511 0.0 0.0 -7.60917440711 0.0 0.0 -7.61917440711 0.0 0.0 -7.62917440711 0.0 0.0 -7.63917440711 0.0 0.0 -7.64515861255 0.0 0.0 -7.65515861255 0.0 0.0 -7.66382532876 0.0 0.0 -7.66472643213 0.0 0.0 -7.6666175051 0.0 0.0 -7.67044057065 0.0 0.0 -7.67813374341 0.0 0.0 -7.68760540483 0.0 0.0 -7.69760540483 0.0 0.0 -7.70760540483 0.0 0.0 -7.71535808103 0.0 0.0 -7.71639706864 0.0 0.0 -7.72639706864 0.0 0.0 -7.73639706864 0.0 0.0 -7.74639706864 0.0 0.0 -7.75639706864 0.0 0.0 -7.76639706864 0.0 0.0 -7.77639706864 0.0 0.0 -7.78534689906 0.0 0.0 -7.79152281972 0.0 0.0 -7.80152281972 0.0 0.0 -7.81152281972 0.0 0.0 -7.82100270281 0.0 0.0 -7.83100270281 0.0 0.0 -7.84100270281 0.0 0.0 -7.84503307903 0.0 0.0 -7.85503307903 0.0 0.0 -7.85994695118 0.0 0.0 -7.86385109327 0.0 0.0 -7.8688829853 0.0 0.0 -7.8788829853 0.0 0.0 -7.88258816814 0.0 0.0 -7.8876106662 0.0 0.0 -7.89171149993 0.0 0.0 -7.89488546195 0.0 0.0 -7.89808555873 0.0 0.0 -7.90020848996 0.0 0.0 -7.90416598896 0.0 0.0 -7.90751751531 0.0 0.0 -7.91091108505 0.0 0.0 -7.91409314165 0.0 0.0 -7.91564972572 0.0 0.0 -7.9196619246 0.0 0.0 -7.9228198676 0.0 0.0 -7.92385629249 0.0 0.0 -7.92534644147 1504.24899292 0.0 -7.9273773813 1268.6939197 0.0 -7.92871848558 3228.71634075 0.0 -7.93121924296 4463.55916169 0.0 -7.93210792431 5837.63630439 0.0 -7.93294649443 9751.04487817 0.0 -7.93604717848 7870.63748341 0.0 -7.93966997994 5041.57160688 0.0 -7.94279586829 2849.25503813 0.0 -7.94627649826 808.240454146 0.0 -7.94932486257 -254.554446826 0.0 -7.95412934732 -333.283498055 0.0 -7.96003317987 -17.1634012172 0.0 -7.9612257101 746.291297355 0.0 -7.96221369052 1207.58015027 0.0 -7.96271369052 1513.46230763 0.0 -7.96807070032 1310.40160752 0.0 -7.97418409256 881.713095371 0.0 -7.9793704999 522.976476833 0.0 -7.98675892668 444.033670016 0.0 -7.99417648121 545.015533199 0.0 -8.00067708316 654.500895809 0.0 -8.00844667002 734.30751214 0.0 -8.0132658515 792.214408111 3.0480808468 -8.01788354524 808.205445709 3.63271424503 -8.02788354524 781.845054858 0.0 -8.03710173571 720.700305665 4.89832865784 -8.04587565279 668.104596898 0.0 -8.05503425671 628.002031844 0.0 -8.06503425671 618.07192252 19.3072880403 -8.07503425671 609.223649845 11.6030771704 -8.08503425671 607.897288011 -4.93221867644 -8.09205918526 599.176369002 69.914466042 -8.10205918526 609.126957433 54.4735301149 -8.11205918526 629.832249766 12.1447691742 -8.12205918526 654.525715382 9.89621730865 -8.13205918526 681.025134723 7.95690733892 -8.14205918526 709.239615233 11.0183153831 -8.15205918526 736.095894548 6.57673264867 -8.16205918526 762.751338047 5.91396233952 -8.16470726262 796.659638054 0.0580470328691 -8.16821500085 823.856450394 5.68921283318 -8.17821500085 846.347933715 6.11197327622 -8.18708694983 867.737191817 11.7838832613 -8.19420230232 880.684047568 1.47478167788 -8.20146699716 900.17734581 -4.83640567009 -8.20784773396 911.442418438 10.8556657193 -8.21454343291 935.124573705 -1.08439617629 -8.22080649244 962.15166451 15.0762806756 -8.22638347142 984.889512624 -15.0112733165 -8.23267916002 1002.91274908 -10.3328202531 -8.2382052876 1024.3235242 0.0 -8.23965214752 1072.30342106 0.0 -8.24507875058 1082.72587519 0.0 -8.24957141209 1076.94608218 0.0 -8.25451262107 1080.23632891 0.0 -8.25584868567 1057.68395214 0.0 -8.25657301562 1068.90604119 0.0 -8.25784209947 1028.31136831 0.0 -8.2601981537 1050.5488044 0.0 -8.26389007925 1058.63388315 0.0 -8.26778460968 1045.58424998 0.0 -8.27147318132 1056.87346067 0.0 -8.2763097068 1066.04370494 0.0 -8.28063529197 1058.78228421 0.0 -8.28377498054 1081.94947137 0.0 -8.28844145561 1076.34891371 0.0 -8.29284303348 1056.87359486 0.0 -8.29598404798 1064.0300808 0.0 -8.2994822455 1037.92669744 0.0 -8.30390839345 1044.99540056 1.07209447658 -8.30757001233 1015.90419197 1.04133025826 -8.31186230234 998.850782144 0.897388822981 -8.31524325791 1005.54397577 0.0 -8.3160386017 976.568189732 0.0 -8.31763460178 982.42765377 0.0 -8.32066116351 971.177288863 0.0 -8.32400874794 953.390731798 0.0 -8.32705789904 939.863592407 0.0 -8.33047058166 912.766571518 0.0 -8.33425869387 879.060218439 0.0 -8.33771957411 846.838384965 0.0 -8.34109768951 832.273173928 0.0 -8.34436170303 801.969596462 0.0 -8.34738247112 805.171205842 0.0 -8.34857317281 778.833427026 0.0 -8.35248399004 771.373346201 0.0 -8.35528003049 760.964258407 0.0 -8.35866921333 752.864633751 0.0 -8.36178454143 753.878003781 0.0 -8.36485360481 746.109239081 0.0 -8.36967217916 729.311822686 0.0 -8.37498979536 706.510763234 0.0 -8.38075502756 693.886655739 0.0 -8.38480745868 615.140451903 0.0 -8.38620255677 590.282806602 0.0 -8.38930337599 564.38140772 0.0 -8.3945363445 529.066215248 -0.731291630869 -8.39860902265 623.666279778 -0.780423288308 -8.4023128466 760.9576103 0.0 -8.40740327572 608.844750849 0.0 -8.41097632884 494.498988896 0.0 -8.41435093694 478.54991804 0.0 -8.41887745338 424.895968688 0.0 -8.42088866548 376.264409341 0.0 -8.4247673043 361.187679416 0.0 -8.42607908632 331.092295255 0.0 -8.42938170274 358.689708356 0.0 -8.43273959482 362.0657438 0.0 -8.44125184727 438.219227708 0.0 -8.44544672305 544.69730332 0.0 -8.45544672305 595.805000698 0.0 -8.46544672305 661.775656859 0.0 -8.46953098476 724.712712288 0.0 -8.47953098476 701.866196986 0.0 -8.48953098476 672.496709423 0.0 -8.49953098476 620.961910301 0.0 -8.50953098476 602.398233964 0.0 -8.51290229323 561.613651798 0.0 -8.51394032159 467.312290154 0.0 -8.52394032159 482.008967874 0.0 -8.53394032159 527.147655254 0.0 -8.54394032159 565.309182756 0.0 -8.55394032159 611.863464337 0.0 -8.56069108668 648.108675209 0.0 -8.57069108668 657.434713665 0.0 -8.58069108668 649.463979604 0.0 -8.58839687795 628.901064701 0.0 -8.59162282168 590.051253228 0.0 -8.59542384667 562.837801942 0.0 -8.60542384667 554.853135549 0.0 -8.61542384667 549.763815807 0.0 -8.62542384667 543.868242538 0.0 -8.63542384667 536.070218037 0.0 -8.64542384667 533.55108459 0.0 -8.65443367226 525.479294425 0.0 -8.66018605614 518.338161965 0.0 -8.66562292092 511.143039479 0.0 -8.67499608775 503.106327866 0.0 -8.68499608775 496.548507645 0.0 -8.68985590044 491.573644762 0.0 -8.69640374719 487.608010793 0.0 -8.70640374719 481.056643005 0.0 -8.71640374719 471.186903211 0.0 -8.72640374719 463.737689573 0.0 -8.73324277068 457.404191565 0.0 -8.73827971354 454.190056112 0.0 -8.74104283624 453.666151434 0.0 -8.74289334824 453.212766584 0.0 -8.74605920275 449.528652777 0.0 -8.75109662978 442.193527456 0.0 -8.75448962643 436.164870852 0.0 -8.75748687201 430.094694382 0.0 -8.76044787386 424.668562363 0.0 -8.76372173715 419.486807103 0.0 -8.76822856211 413.652653731 0.0 -8.77243205487 405.907116052 0.0 -8.77508400664 405.155550794 0.0 -8.7772168682 401.30098577 0.0 -8.78019474079 396.044617169 0.0 -8.78236591812 392.450231012 0.0 -8.78488108963 387.808190133 0.0 -8.78732599991 383.554422083 0.0 -8.79069625845 377.30021824 0.0 -8.79341566145 372.645295511 0.0 -8.79839577222 361.725329106 0.0 -8.80200691468 355.13038242 0.0 -8.8058003143 348.544582096 0.0 -8.80989699827 341.382102923 0.0 -8.81328823542 332.644873673 0.0 -8.81782836377 321.254436055 0.0 -8.82154099013 313.786707331 0.0 -8.82566485801 305.606498856 0.0 -8.8305834185 296.773362407 0.0 -8.83406842711 288.116308271 0.0 -8.83645130571 283.64649034 0.0 -8.84058282041 276.4643266 0.0 -8.84355808214 277.516294876 0.0 -8.84787708283 269.503120891 0.0 -8.85047491558 262.216477232 0.0 -8.85097491558 253.43327572 0.0 -8.85591675646 245.645419986 0.0 -8.86157591693 232.114512555 0.0 -8.86402257203 222.370659395 0.0 -8.86838170594 211.304397387 0.0 -8.87240348596 197.173018044 0.0 -8.87532702788 186.625127026 0.0 -8.87907105264 177.094859951 0.0 -8.88314924488 157.183405502 0.0 -8.88786871315 135.817776634 0.0 -8.89202694215 123.105451759 0.0 -8.89710231027 107.839839968 0.0 -8.90328158359 92.92895095 0.0 -8.90877494521 84.0626954589 0.0 -8.91050615819 81.7273104118 0.0 -8.91508950801 78.5472435873 0.0 -8.91921654275 69.5335715742 0.0 -8.92288312155 65.3582079845 0.0 -8.92729607596 59.1811634419 0.0 -8.93306594198 22.1216218215 0.0 -8.93917671554 15.6662672169 0.0 -8.94592395666 10.3756321849 0.0 -8.9527384574 9.20921908511 0.0 -8.9596852959 24.4254651488 0.0 -8.96709788051 -8.76825589584 0.0 -8.97491609317 -22.7112121759 0.0 -8.98302298815 -31.847179952 0.0 -8.991689474 -33.0650249873 0.0 -8.99917133419 -8.79212960856 0.0 -9.00791798368 -25.0740378666 0.0 -9.0173464368 -61.6295600121 0.0 -9.0273464368 -20.8910425029 0.0 -9.0373464368 0.0 0.0 -9.0473464368 0.0 0.0 -9.0573464368 0.0 0.0 -9.0624732983 0.0 0.0 -9.06962444579 0.0 0.0 -9.07962444579 0.0 0.0 -9.08465496217 0.0 0.0 -9.09231201447 0.0 0.0 -9.10231201447 0.0 0.0 -9.11231201447 0.0 0.0 -9.12231201447 0.0 0.0 -9.13018297405 0.0 0.0 -9.14018297405 0.0 0.0 -9.14925406986 0.0 0.0 -9.1510982891 0.0 0.0 -9.16089280607 0.0 0.0 -9.17003992389 0.0 0.0 -9.178384117 0.0 0.0 -9.18573820607 0.0 0.0 -9.19267374976 0.0 0.0 -9.19966843506 0.0 0.0 -9.20595290834 0.0 0.0 -9.21188465553 0.0 0.0 -9.21831739352 0.0 0.0 -9.22527859188 0.0 0.0 -9.23136200111 0.0 0.0 -9.23817792322 0.0 0.0 -9.24563215572 0.0 0.0 -9.25153509171 0.0 0.0 -9.25925558006 0.0 0.0 -9.26811382386 0.0 0.0 -9.27608159268 0.0 0.0 -9.28162492132 0.0 0.0 -9.28530355225 0.0 0.0 -9.28953528295 0.0 0.0 -9.29323913483 0.0 0.0 -9.29707671092 0.0 0.0 -9.30190115117 0.0 0.0 -9.30682411604 0.0 0.0 -9.3120254389 0.0 0.0 -9.31864536298 0.0 0.0 -9.32465990285 0.0 0.0 -9.32540804644 0.0 0.0 -9.32606588735 0.0 0.0 -9.32902882599 0.0 0.0 -9.33054850449 0.0 0.0 -9.33344196907 0.0 0.0 -9.33837416251 0.0 0.0 -9.3420262112 0.0 0.0 -9.34308154512 0.0 0.0 -9.34448448575 0.0 0.0 -9.34651365826 0.0 0.0 -9.34842667052 0.0 0.0 -9.35096304871 0.0 0.0 -9.35480742177 0.0 0.0 -9.36014151123 0.0 0.0 -9.36162915245 0.0 0.0 -9.36789344653 0.0 0.0 -9.36873319133 0.0 0.0 -9.37407726573 0.0 0.0 -9.3781530489 0.0 0.0 -9.38583398445 0.0 0.0 -9.39024384655 0.0 0.0 -9.39582486284 0.0 0.0 -9.40114626019 0.0 0.0 -9.40780445884 0.0 0.0 -9.41779948351 0.0 0.0 -9.42694806881 0.0 0.0 -9.43110033246 0.0 0.0 -9.43407487994 0.0 0.0 -9.44407487994 0.0 0.0 -9.44849907855 0.0 0.0 -9.45231727796 0.0 0.0 -9.46038573086 0.0 0.0 -9.46437547786 0.0 0.0 -9.47437547786 0.0 0.0 -9.47752482391 0.0 0.0 -9.47911904921 0.0 0.0 -9.48911904921 0.0 0.0 -9.49868119822 0.0 0.0 -9.50454104047 0.0 0.0 -9.51454104047 0.0 0.0 -9.51992667373 0.0 0.0 -9.52992667373 0.0 0.0 -9.53992667373 0.0 0.0 -9.54992667373 0.0 0.0 -9.55194973082 0.0 0.0 -9.55359502049 0.0 0.0 -9.56359502049 0.0 0.0 -9.57359502049 0.0 0.0 -9.58359502049 0.0 0.0 -9.59359502049 0.0 0.0 -9.60359502049 0.0 0.0 -9.61359502049 0.0 0.0 -9.61942495356 0.0 0.0 -9.62566553442 0.0 0.0 -9.63014846163 0.0 0.0 -9.63769517317 0.0 0.0 -9.64769517317 0.0 0.0 -9.65769517317 0.0 0.0 -9.66769517317 0.0 0.0 -9.67769517317 0.0 0.0 -9.68769517317 0.0 0.0 -9.69769517317 0.0 0.0 -9.70769517317 0.0 0.0 -9.71769517317 0.0 0.0 -9.72769517317 0.0 0.0 -9.73769517317 0.0 0.0 -9.73999766969 0.0 0.0 -9.74957561904 0.0 0.0 -9.75957561904 0.0 0.0 -9.7679554454 0.0 0.0 -9.77766508827 0.0 0.0 -9.78580810275 0.0 0.0 -9.79114430912 0.0 0.0 -9.79565873068 0.0 0.0 -9.79827282069 0.0 0.0 -9.80172815049 0.0 0.0 -9.80584567946 0.0 0.0 -9.81055387539 0.0 0.0 -9.81653139451 2381.16055842 0.0 -9.82070827675 2829.14351923 0.0 -9.8247484074 3848.25320504 0.0 -9.82624298563 6295.67294556 0.0 -9.828025127 5845.54061879 0.0 -9.83173429499 4939.63959663 0.0 -9.83498852688 3484.83401046 0.0 -9.83912612993 2174.88885829 0.0 -9.84416954152 1139.39229246 0.0 -9.84804084103 481.0678839 0.0 -9.85339622055 204.06585913 0.0 -9.86149001781 330.716114048 0.0 -9.86827881298 514.880056006 0.0 -9.87489869732 693.206717224 -0.367482271919 -9.88263513838 798.305606055 0.0 -9.89060966504 889.692106872 0.0 -9.89935382471 905.622833761 0.0 -9.90935382471 884.212312801 1.35248371398 -9.9192517923 837.908827151 1.37110751543 -9.9292517923 789.628259668 0.0 -9.9392517923 746.710320383 0.0 -9.9492517923 717.2313449 0.0 -9.9592517923 706.221985144 0.0 -9.9692517923 692.157442945 0.0 -9.9792517923 691.396288673 0.0 -9.9892517923 703.009778848 0.0 -9.9992517923 722.451602528 0.0 -10.0092517923 742.031346553 -0.47015389405 -10.0192517923 760.760768869 3.50573352 -10.0292517923 780.438600626 6.83915696992 -10.0392517923 802.542260908 3.49877511066 -10.0492517923 822.867137736 3.62500160419 -10.0592517923 848.451840468 3.54400424588 -10.0653033658 871.338248993 3.33000463819 -10.0713235364 889.981343889 4.46985036294 -10.080986158 913.921296513 0.0 -10.090986158 941.737032172 0.0 -10.1006878135 969.193138553 0.0 -10.1083145635 1006.76848193 0.0 -10.1183145635 1039.11310444 -0.927823988394 -10.1283145635 1063.45911608 3.13649315457 -10.1383145635 1085.26407219 0.0 -10.1481111743 1104.19715464 0.0 -10.1565545304 1117.06163369 0.0 -10.163898259 1127.16842403 0.0 -10.1703080836 1129.18114464 0.0 -10.1782038878 1125.85949884 0.0 -10.1848375699 1110.02388544 0.0 -10.1914152418 1084.97761283 0.0 -10.1960376436 1055.37446564 0.0 -10.2033270055 1041.27543861 0.0 -10.2097047569 1026.54994281 1.72106265384 -10.2145825158 1004.85655754 1.59826821006 -10.2197110215 986.259943359 0.0 -10.224041554 970.596965907 0.0 -10.2297003506 971.67049264 0.0 -10.2340830503 976.458905892 0.0 -10.2392733574 989.331792866 0.0 -10.2460179825 991.862151995 0.455371937889 -10.2522577853 935.093791976 0.338856669906 -10.2576082479 872.57056237 0.0 -10.2632978309 899.233012979 0.0 -10.2649511133 866.269037223 0.0 -10.2690355425 839.8330852 0.0 -10.2700171299 766.537721007 0.0 -10.2770933994 742.000912055 0.0 -10.2870933994 691.002118595 0.0 -10.2899688918 643.458901572 0.0 -10.2939438914 605.765786946 0.0 -10.2974317136 581.165818405 0.0 -10.3026219083 562.723690974 0.0 -10.3084649585 540.476613035 0.0 -10.3107689688 1069.57873156 0.0 -10.3168903861 942.677079116 4.38901864723 -10.3256266518 803.058763112 0.0 -10.3291702445 709.197531563 0.0 -10.3328362023 781.480261788 0.0 -10.3392055497 780.094549593 0.0 -10.345394682 753.73513679 0.0 -10.3489000613 697.085471481 0.0 -10.3540542944 636.814716028 0.0 -10.3570865418 583.783169269 0.0 -10.3608612352 546.300052812 0.0 -10.364980708 581.773538452 0.0 -10.3729482934 606.683310396 0.0 -10.3786794978 729.78544593 0.0 -10.3850575096 757.478313461 0.0 -10.3896653741 814.594788631 0.0 -10.3925311176 861.05553995 0.0 -10.3959427956 830.766898118 0.0 -10.4021251129 780.420033789 0.0 -10.4121251129 713.747766241 0.0 -10.4179890852 643.367940111 0.0 -10.4221998013 590.101131946 0.0 -10.4321998013 574.943997528 0.0 -10.4421998013 583.298909293 0.0 -10.4521998013 596.408555599 0.0 -10.4621998013 613.339981505 0.0 -10.4721998013 621.838851349 0.0 -10.4821998013 627.427031457 0.0 -10.4921168529 630.561857601 0.0 -10.4952747657 636.259697941 0.0 -10.5014115143 629.51554726 0.0 -10.5114115143 615.276210329 0.0 -10.5214115143 591.500272861 0.0 -10.5314115143 570.744873705 0.0 -10.5411222444 551.901797485 0.0 -10.5511222444 538.067376461 0.0 -10.5611222444 525.940373996 0.0 -10.5711222444 514.283690134 0.0 -10.5811222444 510.649693552 0.0 -10.5877260015 511.266373032 0.0 -10.5902644246 520.681337295 0.0 -10.5912288289 537.948507384 0.0 -10.6012288289 521.57376706 0.0 -10.6103668996 500.5780855 0.0 -10.6125479139 472.444436958 0.0 -10.6166249057 461.920011602 0.0 -10.6260865753 446.794645226 0.0 -10.6306896316 437.688513313 0.0 -10.6406896316 425.177943491 0.0 -10.6438722537 423.284710273 0.0 -10.6538722537 408.80173661 0.0 -10.6636205466 395.457651781 0.0 -10.6728037421 380.688927308 0.0 -10.6828037421 368.297319916 0.0 -10.692690882 354.279926397 0.0 -10.700327342 342.21929359 0.0 -10.7043252424 338.338331318 0.0 -10.7069132668 338.397364413 0.0 -10.7096263856 336.014390252 0.0 -10.7130556457 329.313027788 0.0 -10.7157134275 326.07579715 0.0 -10.7193648254 306.912165624 0.0 -10.7217715915 293.541011118 0.0 -10.7250856263 283.291827535 0.0 -10.7287542158 284.99493599 0.0 -10.7340182307 251.495056587 0.0 -10.7374010851 251.002223958 0.0 -10.7410037661 250.705097516 0.0 -10.7442484663 248.864472774 0.0 -10.7462743391 249.188619798 0.0 -10.7485323902 257.967744517 0.0 -10.7512676738 225.69139581 0.0 -10.755651304 218.921623137 0.0 -10.757836272 216.205327997 0.0 -10.7613936362 211.700953852 0.0 -10.7639095202 207.068708199 0.0 -10.7656712659 203.069817965 0.0 -10.7673220029 190.932563511 0.0 -10.7694712169 182.086606208 0.0 -10.7725130001 176.879690033 0.0 -10.7757074479 172.131554324 0.0 -10.7799554747 168.027497982 0.0 -10.7843057857 162.251286075 0.0 -10.7884920972 146.207893715 0.0 -10.7927951341 138.598139266 0.0 -10.7978428624 121.100052454 0.0 -10.8033293447 116.023442848 0.0 -10.8090833316 109.39499329 0.0 -10.8149773452 97.4935080537 0.0 -10.8212524329 88.1493364882 0.0 -10.8272848165 70.2000918248 0.0 -10.8334069867 67.6018801411 0.0 -10.8396228428 54.7611106356 0.0 -10.8472485161 41.3495038625 0.0 -10.8537642141 41.316127128 0.0 -10.8604557945 35.7592200546 0.0 -10.8673404125 29.3119607941 0.0 -10.874426975 29.3970007089 0.0 -10.8834583027 15.7614532882 0.0 -10.892893719 -1.02670661441 0.0 -10.8991395612 0.725896116578 0.0 -10.901653729 -4.93903982122 0.0 -10.9062305676 -16.624107563 0.0 -10.9162305676 -36.2772380032 0.0 -10.9262305676 -48.5654678787 0.0 -10.9362305676 0.0 0.0 -10.9429775662 0.0 0.0 -10.9479518702 0.0 0.0 -10.9540729328 0.0 0.0 -10.9640729328 0.0 0.0 -10.9740729328 0.0 0.0 -10.9840729328 0.0 0.0 -10.9940729328 0.0 0.0 -11.0040729328 0.0 0.0 -11.0140729328 0.0 0.0 -11.0150704699 0.0 0.0 -11.0156635609 0.0 0.0 -11.0251049357 0.0 0.0 -11.0291775181 0.0 0.0 -11.0344223325 0.0 0.0 -11.0437378188 0.0 0.0 -11.0517822134 0.0 0.0 -11.0617822134 0.0 0.0 -11.0705416461 0.0 0.0 -11.0785394814 0.0 0.0 -11.0856660286 0.0 0.0 -11.0934019178 0.0 0.0 -11.1034019178 0.0 0.0 -11.1114379761 0.0 0.0 -11.1207625513 0.0 0.0 -11.1252427418 0.0 0.0 -11.1279852313 0.0 0.0 -11.1336976753 0.0 0.0 -11.1436177957 0.0 0.0 -11.1531296019 0.0 0.0 -11.1612989048 0.0 0.0 -11.169373133 0.0 0.0 -11.1772952693 0.0 0.0 -11.184462568 0.0 0.0 -11.1893553512 0.0 0.0 -11.195094241 0.0 0.0 -11.1996577919 0.0 0.0 -11.2059469802 0.0 0.0 -11.2122694791 0.0 0.0 -11.2180806648 0.0 0.0 -11.2236833745 0.0 0.0 -11.2291728617 0.0 0.0 -11.2326300255 0.0 0.0 -11.2360802242 0.0 0.0 -11.2412773221 0.0 0.0 -11.2462425504 0.0 0.0 -11.2508911108 0.0 0.0 -11.2563956869 0.0 0.0 -11.2616666342 0.0 0.0 -11.2696780667 0.0 0.0 -11.2796780667 0.0 0.0 -11.2872226752 0.0 0.0 -11.2903604434 0.0 0.0 -11.2943404314 0.0 0.0 -11.3007487318 0.0 0.0 -11.3098533705 0.0 0.0 -11.3165724403 0.0 0.0 -11.3260098788 0.0 0.0 -11.3358001249 0.0 0.0 -11.3458001249 0.0 0.0 -11.3496137235 0.0 0.0 -11.3510897623 0.0 0.0 -11.3610897623 0.0 0.0 -11.3710897623 0.0 0.0 -11.3810897623 0.0 0.0 -11.3910897623 0.0 0.0 -11.4010897623 0.0 0.0 -11.4101915822 0.0 0.0 -11.4201103404 0.0 0.0 -11.4266582236 0.0 0.0 -11.4366582236 0.0 0.0 -11.4466582236 0.0 0.0 -11.4566582236 0.0 0.0 -11.4609847845 0.0 0.0 -11.4709847845 0.0 0.0 -11.4809847845 0.0 0.0 -11.4909847845 0.0 0.0 -11.5009847845 0.0 0.0 -11.5109847845 0.0 0.0 -11.5209847845 0.0 0.0 -11.5309847845 0.0 0.0 -11.5409847845 0.0 0.0 -11.5509847845 0.0 0.0 -11.5596093426 0.0 0.0 -11.5652215869 0.0 0.0 -11.5713002802 0.0 0.0 -11.5781536626 0.0 0.0 -11.5845492162 0.0 0.0 -11.5912852722 0.0 0.0 -11.5939517383 0.0 0.0 -11.6004509269 0.0 0.0 -11.6059662092 0.0 0.0 -11.6102741843 0.0 0.0 -11.6152536596 0.0 0.0 -11.6176339129 0.0 0.0 -11.6204752077 0.0 0.0 -11.6239531045 0.0 0.0 -11.6321913298 0.0 0.0 -11.6421913298 0.0 0.0 -11.6477948665 0.0 0.0 -11.6537489833 0.0 0.0 -11.6544376825 0.0 0.0 -11.6644376825 0.0 0.0 -11.673368853 0.0 0.0 -11.6749648427 0.0 0.0 -11.6770245699 0.0 0.0 -11.6819690187 984.363360168 0.0 -11.6849435124 1751.0746579 0.0 -11.6866302436 5534.52282757 0.0 -11.6892286476 4412.87288353 0.0 -11.6923474994 3247.94434633 0.0 -11.6969989456 1308.28399223 0.0 -11.6991844145 2029.08584939 0.0 -11.7052448576 1500.32755121 0.0 -11.7099532439 973.057798045 0.0 -11.7151040217 789.24020995 0.0 -11.7209927804 716.312673171 0.0 -11.7265821436 700.214629193 0.0 -11.7348615038 821.643669761 0.0 -11.7446314883 880.346068029 0.0 -11.7546314883 903.814606158 0.0 -11.7640802684 880.969114624 0.0 -11.7718095156 822.545449724 0.0 -11.7818095156 788.528617999 0.0 -11.7914805571 762.433822181 0.0 -11.8014805571 740.989802304 0.0 -11.8114805571 731.972025125 0.0 -11.8214805571 724.234343875 -26.5230090274 -11.8314805571 723.883408349 0.0 -11.8352495593 687.953384628 0.0 -11.8433588148 694.67844241 0.0 -11.8527273935 708.799771216 0.0 -11.8627273935 728.609028538 0.0 -11.8727273935 750.159545011 17.796445891 -11.874651798 767.595238799 17.8131087527 -11.8759360996 793.575724723 17.6729122607 -11.8813266815 796.758191939 30.419457731 -11.8913266815 809.44747894 18.2105981598 -11.8982662351 812.839106169 15.7946018937 -11.9019941812 800.432912215 11.8205177583 -11.9065315732 796.919204255 9.85701634735 -11.9156370259 813.409934614 8.95451255259 -11.9256370259 833.700508753 12.9520013893 -11.9313705222 851.784266854 2.30462093459 -11.9413705222 879.804919146 -4.53175275495 -11.9513705222 909.602407901 -8.30943181757 -11.9613705222 941.292335471 18.6652490559 -11.9713705222 978.757075119 14.9514666954 -11.9813705222 1016.4078593 13.0583249192 -11.9913705222 1054.25841106 8.37350836627 -12.0013705222 1084.16769847 -6.44564566329 -12.0057935121 1120.33742854 0.0 -12.0112330561 1136.16246257 0.0 -12.0175385712 1136.01317649 0.0 -12.0224410884 1130.7888887 0.0 -12.0271644808 1122.58303927 0.0 -12.0317696708 1114.13063359 0.0 -12.036362878 1096.66545446 2.72620354302 -12.0407846388 1077.17655194 2.64918034714 -12.0449088901 1066.04608066 0.0 -12.0486550846 1054.37887604 0.0 -12.0523809733 1038.56253579 1.73209998769 -12.0561132054 1025.41516925 1.80672818822 -12.0600015299 1009.99055763 1.91214894324 -12.0641880865 995.272110858 1.98046408311 -12.0692764812 976.59874577 0.0 -12.0746917767 972.229468932 0.0 -12.0784922949 962.370258149 0.0 -12.0850113499 970.545139555 0.0 -12.0924153706 1002.83659617 0.0 -12.1004855799 996.177558121 0.0 -12.1104855799 976.468684924 0.0 -12.1204855799 917.362174706 0.0 -12.1294800807 819.939128637 0.0 -12.1360155378 780.108532008 -0.679682729685 -12.1411697143 708.51569667 4.22429039658 -12.1452132013 652.209398749 -7.52512759919 -12.1525436922 694.636747544 0.0 -12.1589679698 670.836975118 0.0 -12.163559318 741.115219181 0.0 -12.1678894411 770.604111873 0.0 -12.1729327342 783.713869697 0.0 -12.1808999182 785.382664148 0.0 -12.1876743767 782.543849981 0.0 -12.1911446119 780.59486988 0.0 -12.1942635232 757.412878302 0.0 -12.1980870877 722.122634501 0.0 -12.20272653 752.774031654 0.0 -12.2065841107 799.768385347 0.0 -12.210829132 802.988109383 0.0 -12.215010405 803.83943769 0.0 -12.218460513 830.103390608 0.0 -12.2236317405 836.977700273 0.0 -12.2292064626 783.998472682 0.0 -12.2348947652 736.015691345 0.0 -12.2403511428 714.239072332 0.0 -12.2500012962 701.647492806 0.0 -12.2596036957 700.979101248 0.0 -12.2682687456 702.235273111 0.0 -12.2748600621 704.181642999 0.0 -12.2817302926 711.005213904 0.0 -12.2888839807 717.549785955 0.0 -12.2946044189 723.427708998 0.0 -12.3014515312 721.456664873 0.0 -12.3049777045 730.479068578 0.0 -12.3102397542 730.794408514 0.0 -12.3152719011 732.665743928 0.0 -12.3185118591 731.026894679 0.0 -12.3231024604 724.843555347 0.0 -12.3275395512 773.910710017 0.0 -12.3317933075 706.501459798 0.0 -12.3363075089 707.512205478 0.0 -12.3405538848 714.371635862 0.0 -12.3446703517 702.202283858 0.0 -12.3486487963 692.32257903 0.0 -12.3525102485 691.382739101 0.0 -12.3562724688 689.844380274 0.0 -12.3599371613 685.632847315 0.0 -12.3635188958 680.30823864 0.0 -12.3670209241 671.384314461 0.0 -12.3704439103 661.387369328 0.0 -12.3737994148 656.112466779 0.0 -12.3770854821 653.349580773 0.0 -12.3803123405 648.437252575 0.0 -12.3834812727 640.609119883 0.0 -12.3865912795 655.22562818 0.0 -12.3896511216 642.969977153 0.0 -12.3926617015 629.862874268 0.0 -12.3956215813 619.194179632 0.0 -12.3985384393 617.481044503 0.0 -12.4014094603 652.696056692 0.0 -12.4042415915 619.93838428 0.0 -12.4070350256 626.516344763 0.0 -12.40978785 643.594142324 0.0 -12.4125063854 656.062310667 0.0 -12.4151907797 659.282965802 0.0 -12.4178390484 654.923026368 0.0 -12.4204569325 645.702448857 0.0 -12.4230416201 652.210911074 0.722189307032 -12.425598347 656.35768826 0.737476966046 -12.4281380371 644.132901432 0.752148247399 -12.4306575421 631.306966365 0.0 -12.4331505513 611.402642368 0.0 -12.4356202049 600.853574417 0.0 -12.4380628335 598.61291898 0.0 -12.4404826825 583.91354975 0.0 -12.4428767169 599.849709857 0.0 -12.4452492094 580.16837384 0.0 -12.4475973027 578.363295536 0.0 -12.4499226647 578.42242212 0.0 -12.4522287253 556.312822692 0.0 -12.4545125643 565.526172261 0.0 -12.4567779102 556.58492949 0.0 -12.4590220603 572.345331442 0.0 -12.4612486587 562.840670754 0.0 -12.4634551111 573.134527771 0.0 -12.4656427273 581.239917068 0.0 -12.4678144942 602.726929757 0.0 -12.4699677528 607.85532923 0.0 -12.4721056962 608.120632398 0.0 -12.4742258696 604.157333636 0.0 -12.4763314057 609.332228844 0.0 -12.4783799604 592.817284201 0.0 -12.480326218 590.938964354 0.0 -12.482279398 606.433749909 0.0 -12.4837886774 668.330468907 0.0 -12.4861372124 599.69482243 0.0 -12.4897904012 608.138797888 0.0 -12.4941420148 586.613113215 0.0 -12.4994275951 598.116543202 0.0 -12.5044886907 635.278380737 0.0 -12.5072254472 595.416364693 0.0 -12.5089725345 539.561554643 0.0 -12.5114898947 512.724173646 0.0 -12.5132205504 469.706339147 0.0 -12.5194040199 439.866060106 0.0 -12.5294040199 399.244220691 0.0 -12.5318030467 381.680494714 0.0 -12.5332137606 428.962280005 0.0 -12.5338339909 424.791556853 0.0 -12.5438339909 395.552037263 0.0 -12.5538339909 380.540039149 0.0 -12.5638339909 363.030759728 0.0 -12.5698858324 360.284912341 0.0 -12.5755120709 360.425478835 0.0 -12.5796555028 368.14998693 0.0 -12.5832030645 375.106495826 0.0 -12.5847965846 403.209471737 0.0 -12.590755595 387.459430555 0.0 -12.5972748613 367.844669359 0.0 -12.6019094517 356.085045109 0.0 -12.6045098915 339.873265627 0.0 -12.6069223087 341.049486462 0.0 -12.6102719092 322.059982035 0.0 -12.6143118773 300.918566531 0.0 -12.6177434344 285.908301886 0.0 -12.6202187039 268.082021322 0.0 -12.6239864037 261.276044024 0.0 -12.6289316173 254.342173074 0.0 -12.6352181587 243.352983867 0.0 -12.6372758994 241.010947396 0.0 -12.640928266 230.478012681 0.0 -12.6452517526 218.50355472 0.0 -12.648282188 213.490649069 0.0 -12.6530768152 205.320791531 0.0 -12.6565880209 195.947388263 0.0 -12.6605973968 188.635711542 0.0 -12.665043251 177.822759182 0.0 -12.6693451376 170.210918367 0.0 -12.6740406023 168.186840374 0.0 -12.6789053414 160.858290256 0.0 -12.6844196774 150.007060557 0.0 -12.6907282842 145.818534564 0.0 -12.6969391678 142.400865552 0.0 -12.7034602626 135.894431759 0.0 -12.7082092474 133.028236345 0.0 -12.7130268233 127.397324642 0.0 -12.7196368361 119.717127031 0.0 -12.7255311998 69.2079765326 0.0 -12.7340063062 85.1227861538 0.0 -12.7425880561 74.7902918399 0.0 -12.7517868197 59.4097327749 0.0 -12.7598632625 38.4002312958 0.0 -12.7678453285 24.1032921277 0.0 -12.7723924647 4.09139462081 0.0 -12.7768270487 -7.41427778334 0.0 -12.7854357056 -16.9815750793 0.0 -12.7954357056 -23.9955076819 0.0 -12.8054357056 -34.7664079247 0.0 -12.8154357056 -44.8663508466 0.0 -12.8254357056 -72.7982820346 0.0 -12.8354357056 -80.1100325234 0.0 -12.8395355875 -73.0388490381 0.0 -12.8432359977 -45.5902792321 0.0 -12.8532359977 -70.7136551929 0.0 -12.8632359977 -59.0647940284 0.0 -12.8708584197 0.0 0.0 -12.8727039247 0.0 0.0 -12.8758606196 0.0 0.0 -12.8822814039 0.0 0.0 -12.8910203903 0.0 0.0 -12.899152498 0.0 0.0 -12.9074377558 0.0 0.0 -12.914137638 0.0 0.0 -12.9199488554 0.0 0.0 -12.9253014525 0.0 0.0 -12.9300222419 0.0 0.0 -12.9353860563 0.0 0.0 -12.9408163225 0.0 0.0 -12.9465916286 0.0 0.0 -12.9511208383 0.0 0.0 -12.95614828 0.0 0.0 -12.9600615636 0.0 0.0 -12.9646329196 0.0 0.0 -12.9691190208 0.0 0.0 -12.9729432034 0.0 0.0 -12.9772884644 0.0 0.0 -12.9813317462 0.0 0.0 -12.9852610441 0.0 0.0 -12.9890598443 0.0 0.0 -12.9927673257 0.0 0.0 -12.9963860061 0.0 0.0 -12.9999542498 0.0 0.0 -13.0034782163 0.0 0.0 -13.007133824 0.0 0.0 -13.0104470284 0.0 0.0 -13.0141342532 0.0 0.0 -13.016353082 0.0 0.0 -13.0187202088 0.0 0.0 -13.0218372944 0.0 0.0 -13.0259086759 0.0 0.0 -13.028460989 0.0 0.0 -13.0290098155 0.0 0.0 -13.0301543038 0.0 0.0 -13.0348252266 0.0 0.0 -13.039107717 0.0 0.0 -13.0431164787 0.0 0.0 -13.0470466695 0.0 0.0 -13.0509831766 0.0 0.0 -13.0550058067 0.0 0.0 -13.0583935192 0.0 0.0 -13.0612292125 0.0 0.0 -13.0637853108 0.0 0.0 -13.0668180414 0.0 0.0 -13.0707323507 0.0 0.0 -13.0746208825 0.0 0.0 -13.0776298658 0.0 0.0 -13.0835966811 0.0 0.0 -13.0892053165 0.0 0.0 -13.0962792803 0.0 0.0 -13.1043205535 0.0 0.0 -13.111308236 0.0 0.0 -13.1156800275 0.0 0.0 -13.1230591977 0.0 0.0 -13.1301734877 0.0 0.0 -13.1378401622 0.0 0.0 -13.1402398466 0.0 0.0 -13.1418162326 0.0 0.0 -13.1451565765 0.0 0.0 -13.1510305923 0.0 0.0 -13.153389566 0.0 0.0 -13.163389566 0.0 0.0 -13.1729146651 0.0 0.0 -13.1774763929 0.0 0.0 -13.1811516415 0.0 0.0 -13.1847094325 0.0 0.0 -13.1918093107 0.0 0.0 -13.2010945951 0.0 0.0 -13.2110945951 0.0 0.0 -13.2210945951 0.0 0.0 -13.2303862217 0.0 0.0 -13.2329121409 0.0 0.0 -13.2429121409 0.0 0.0 -13.2489923225 0.0 0.0 -13.2542939752 0.0 0.0 -13.2609862018 0.0 0.0 -13.267203398 0.0 0.0 -13.2713912161 0.0 0.0 -13.2747405301 0.0 0.0 -13.2785762465 0.0 0.0 -13.2819114864 0.0 0.0 -13.2834064205 0.0 0.0 -13.2867741033 0.0 0.0 -13.2897996622 0.0 0.0 -13.2935400599 0.0 0.0 -13.2990815286 0.0 0.0 -13.3055105252 0.0 0.0 -13.3078087817 0.0 0.0 -13.3092772068 0.0 0.0 -13.3192772068 0.0 0.0 -13.3292772068 0.0 0.0 -13.3372016911 0.0 0.0 -13.3418776527 0.0 0.0 -13.3518776527 0.0 0.0 -13.3618776527 0.0 0.0 -13.3718776527 0.0 0.0 -13.380283741 0.0 0.0 -13.3864860554 0.0 0.0 -13.3935155792 0.0 0.0 -13.395441801 0.0 0.0 -13.4024338658 0.0 0.0 -13.4097800303 0.0 0.0 -13.415218787 0.0 0.0 -13.4170198188 0.0 0.0 -13.4211966504 0.0 0.0 -13.4241599986 0.0 0.0 -13.4263824648 0.0 0.0 -13.4282649428 0.0 0.0 -13.4300789392 0.0 0.0 -13.4316397181 0.0 0.0 -13.4321397181 0.0 0.0 -13.4326472962 0.0 0.0 -13.4348151871 0.0 0.0 -13.4378242533 0.0 0.0 -13.4403790017 0.0 0.0 -13.4431996354 0.0 0.0 -13.4454551819 0.0 0.0 -13.4467970055 0.0 0.0 -13.4499756439 0.0 0.0 -13.4511350068 0.0 0.0 -13.4530119848 0.0 0.0 -13.4589543143 0.0 0.0 -13.4630162746 0.0 0.0 -13.4687797409 0.0 0.0 -13.4787797409 0.0 0.0 -13.4868486408 0.0 0.0 -13.4945528325 0.0 0.0 -13.5045528325 0.0 0.0 -13.5105516698 0.0 0.0 -13.5142110113 0.0 0.0 -13.5148842356 0.0 0.0 -13.5155939451 0.0 0.0 -13.5255939451 0.0 0.0 -13.5355939451 0.0 0.0 -13.5426266876 0.0 0.0 -13.546970526 0.0 0.0 -13.5537630974 0.0 0.0 -13.5558559016 0.0 0.0 -13.5590218692 0.0 0.0 -13.5634579829 0.0 0.0 -13.5696370844 1976.79212678 0.0 -13.5726208882 4276.77739503 0.0 -13.5756585146 4440.55131003 0.0 -13.5800134345 3494.80239092 0.0 -13.584679446 2629.69289665 0.0 -13.5907201162 1205.24265088 0.0 -13.5982450547 726.455336832 0.0 -13.6028078704 412.646125997 0.0 -13.6089633235 339.160004726 0.0 -13.6147783819 376.863332236 0.0 -13.6200929231 466.977931943 0.0 -13.6260336684 669.513258395 0.0 -13.6293459703 873.212615679 0.0 -13.6357785781 918.328262148 0.0 -13.6428356919 921.160293186 0.0 -13.6501514263 902.65446854 0.0 -13.6592677053 872.630819661 0.0 -13.6692677053 827.816464329 0.595067686003 -13.6790042029 779.221183469 0.0 -13.6882535037 739.017880206 0.0 -13.6970249559 696.827302489 0.0 -13.7070249559 681.745725913 0.0 -13.7170249559 673.438138906 0.0 -13.7270249559 676.479504072 15.6573373958 -13.7370249559 687.248172748 20.904141519 -13.7470249559 699.981294695 30.4679660278 -13.7570249559 712.966821324 26.0949896952 -13.7670249559 728.109812549 25.6503428565 -13.7759792413 745.35099391 26.2392203359 -13.7786900187 751.90180317 22.6878330776 -13.7826224187 761.199145509 31.3598111928 -13.7900379868 778.615030715 11.903240127 -13.8000379868 804.959368737 18.4897975246 -13.8100379868 826.599992898 16.6051988688 -13.8167195038 841.807946425 20.0134331258 -13.8267195038 865.61028367 10.1342042871 -13.8367195038 886.93977185 6.48463037176 -13.8467195038 912.8412872 -3.03838205986 -13.8540711563 939.968098282 -9.2606403164 -13.855866341 979.841635829 -14.5169499387 -13.8587993528 994.716804641 0.0 -13.8650672635 1003.36561168 0.0 -13.8750672635 1019.09979122 0.0 -13.8850672635 1023.3934954 0.0 -13.889546526 1012.32659139 0.0 -13.8924972027 995.367813759 0.0 -13.8973550743 999.0579555 0.0 -13.9066895072 1010.28992369 0.0 -13.9082941584 1044.17957954 0.0 -13.9182941584 1047.24836586 0.0 -13.9261139634 1050.16308135 0.0 -13.9342823114 1054.55396662 0.0 -13.9403096087 1055.80825668 108.958857365 -13.946486765 1038.96682363 0.0 -13.9553216101 1046.88049951 0.0 -13.9627797286 1056.67125057 0.0 -13.9702413591 1034.11807552 0.0 -13.9748516523 1000.74269802 0.0 -13.9806089356 1007.30538921 0.0 -13.9865124068 991.413806691 0.0 -13.9940826505 980.9577362 1.31442844746 -14.0014435378 929.04019446 0.0 -14.0101840409 859.71761148 0.0 -14.0172355135 830.327452032 0.0 -14.0224877956 832.636342577 0.0 -14.0261575213 910.028228875 0.0 -14.0315160909 824.159135553 0.0 -14.0386497097 808.023156641 0.0 -14.0419726526 783.688326602 0.0 -14.0441652184 785.299931937 0.0 -14.0467680887 935.159355175 0.0 -14.0516283411 940.168032859 0.0 -14.0568645852 894.019237765 0.0 -14.0638022847 845.602903581 0.0 -14.0697601982 908.257167006 0.0 -14.0761894826 883.031759637 0.0 -14.0789299839 867.779306885 0.0 -14.0825409029 918.723627694 0.0 -14.0901401361 922.929965827 0.0 -14.0968804436 868.278870121 0.0 -14.1020068827 809.27588339 0.0 -14.1101134434 769.532244084 0.0 -14.1146089168 750.797992545 0.0 -14.1215392201 738.418234786 0.0 -14.1230743292 702.167163847 0.0 -14.1244756246 695.685060007 0.0 -14.1344756246 718.365584189 0.0 -14.1444756246 730.707053285 0.0 -14.1493970609 782.751677312 0.0 -14.1593970609 790.669680794 0.0 -14.1693970609 803.826122998 0.0 -14.1790738714 802.906784803 0.0 -14.1834537824 797.925477591 0.0 -14.1934537824 794.938287235 0.0 -14.2034537824 783.321436806 0.0 -14.2081997307 778.5373584 0.0 -14.2121656934 767.807570571 0.0 -14.213119106 739.110005299 0.0 -14.223119106 723.904801519 0.0 -14.2278297764 734.27012779 0.0 -14.2378297764 723.072920983 0.0 -14.2478297764 714.578023949 0.0 -14.256211625 705.431438727 0.0 -14.2580884998 714.188089113 0.0 -14.2680884998 709.240644046 0.0 -14.2780884998 693.177539968 0.0 -14.2880884998 676.34379832 0.0 -14.2980884998 661.187946652 0.0 -14.3080884998 644.736640268 0.0 -14.3180884998 624.192392731 0.0 -14.3280884998 610.180227488 0.0 -14.3380884998 591.652383576 0.0 -14.3480884998 577.047402249 0.0 -14.3546366927 566.537835489 0.0 -14.3605200547 561.314047116 0.0 -14.3705200547 543.751798937 0.0 -14.3793550164 533.398205558 0.0 -14.3808769765 541.247348918 0.0 -14.3908769765 524.896773034 0.0 -14.4008769765 502.560620082 0.0 -14.4087462321 493.46288207 0.0 -14.4107040388 501.937908814 0.0 -14.4145219215 496.335422681 0.0 -14.424235446 476.958023791 0.0 -14.4296926426 467.94723026 0.0 -14.4396926426 440.835100872 0.0 -14.4496926426 415.338191927 0.0 -14.4596926426 385.421166416 0.0 -14.4657257237 364.660909478 0.0 -14.4673042993 345.361470181 0.0 -14.4773042993 324.887671584 0.0 -14.4866184246 304.905967085 0.0 -14.4937542144 301.828566911 0.0 -14.5037542144 284.756997688 0.0 -14.5085914914 282.609465001 0.0 -14.5180046096 255.639928768 0.0 -14.5280046096 242.188552473 0.0 -14.5344424225 227.115048678 0.0 -14.5404327007 213.609538032 0.0 -14.545868902 186.143524371 0.0 -14.5469934571 194.303068622 0.0 -14.5476709945 209.09717623 0.0 -14.5513632735 202.746291242 0.0 -14.5558369375 203.464342665 0.0 -14.5590489981 193.486886708 0.0 -14.5635054852 174.011184179 0.0 -14.5672156786 161.866426574 0.0 -14.5726834033 148.55305677 0.0 -14.5746371254 140.740063083 0.0 -14.5817453032 127.945765661 0.0 -14.5884401517 119.841944149 0.0 -14.5952377739 110.949110159 0.0 -14.6029722237 101.590524741 0.0 -14.6050874079 97.8331082412 0.0 -14.6111323807 75.3738600719 0.0 -14.6161301564 78.2538467968 0.0 -14.623829802 75.4224389194 0.0 -14.6316397391 65.3901841576 0.0 -14.6400716618 42.5353311657 0.0 -14.6495041903 30.531533193 0.0 -14.6585050704 20.748935403 0.0 -14.662843289 6.6448466877 0.0 -14.6688012411 7.27068752621 0.0 -14.6721961839 16.6122181315 0.0 -14.6803448209 -7.56141759119 0.0 -14.6817331204 6.58950549672 0.0 -14.6822331204 -10.8977874951 0.0 -14.6922331204 -21.0374948764 0.0 -14.7022331204 -67.9957159604 0.0 -14.7122331204 -27.3623140953 0.0 -14.7222331204 -86.3126389326 0.0 -14.7306747234 -98.882640407 0.0 -14.7406747234 -25.6878602981 0.0 -14.7506747234 0.0 0.0 -14.7606747234 0.0 0.0 -14.7706747234 0.0 0.0 -14.7784447453 0.0 0.0 -14.7842564802 0.0 0.0 -14.7907987759 0.0 0.0 -14.7943187531 0.0 0.0 -14.8002142099 0.0 0.0 -14.8048658571 0.0 0.0 -14.8093259862 0.0 0.0 -14.8144166609 0.0 0.0 -14.8193156419 0.0 0.0 -14.8242467759 0.0 0.0 -14.8294504622 0.0 0.0 -14.8349198046 0.0 0.0 -14.8410655758 0.0 0.0 -14.8476327599 0.0 0.0 -14.8535861122 0.0 0.0 -14.8593583078 0.0 0.0 -14.8651661284 0.0 0.0 -14.8705184068 0.0 0.0 -14.8755318968 0.0 0.0 -14.8802469927 0.0 0.0 -14.8849455964 0.0 0.0 -14.8894550908 0.0 0.0 -14.8937595066 0.0 0.0 -14.8978946192 0.0 0.0 -14.901895631 0.0 0.0 -14.9057677117 0.0 0.0 -14.9090528388 0.0 0.0 -14.9129597041 0.0 0.0 -14.9166008025 0.0 0.0 -14.9201675276 0.0 0.0 -14.923966563 0.0 0.0 -14.9276801882 0.0 0.0 -14.9315310526 0.0 0.0 -14.9352743647 0.0 0.0 -14.9389501992 0.0 0.0 -14.941780474 0.0 0.0 -14.9448084685 0.0 0.0 -14.9478355379 0.0 0.0 -14.9510416408 0.0 0.0 -14.9540046305 0.0 0.0 -14.957027566 0.0 0.0 -14.9599192641 0.0 0.0 -14.9630304996 0.0 0.0 -14.9661430035 0.0 0.0 -14.9699716573 0.0 0.0 -14.9729105087 0.0 0.0 -14.9765516519 0.0 0.0 -14.9795630008 0.0 0.0 -14.9837945405 0.0 0.0 -14.9888284685 0.0 0.0 -14.995608516 0.0 0.0 -15.001082351 0.0 0.0 -15.0070691299 0.0 0.0 -15.0124065005 0.0 0.0 -15.0157450036 0.0 0.0 -15.0191767788 0.0 0.0 -15.0221031418 0.0 0.0 -15.0240793769 0.0 0.0 -15.0306507367 0.0 0.0 -15.0367407758 0.0 0.0 -15.0433854581 0.0 0.0 -15.0474396934 0.0 0.0 -15.053842077 0.0 0.0 -15.0601313498 1.60075446707 0.0 -15.0653193883 1.77151086182 0.0 -15.0714347853 0.0 0.0 -15.076771265 0.0 0.0 -15.0808172857 0.0 0.0 -15.0846473461 0.0 0.0 -15.0911240288 0.0 0.0 -15.0934195532 0.0 0.0 -15.0998013657 0.0 0.0 -15.1060679943 100.816737868 0.0 -15.111985414 657.682700707 0.0 -15.1188470162 0.0 0.0 -15.1243533272 0.0 0.0 -15.1248533272 0.0 0.0 -15.1348533272 0.0 0.0 -15.1378852299 0.0 0.0 -15.1462398368 0.0 0.0 -15.1561893141 0.0 0.0 -15.1658135958 0.0 0.0 -15.1723989062 0.0 0.0 -15.1742275431 0.0 0.0 -15.1764487712 0.0 0.0 -15.1864487712 0.0 0.0 -15.1964487712 0.0 0.0 -15.2033602251 0.0 0.0 -15.2073802671 0.0 0.0 -15.2089696877 0.0 0.0 -15.2119427987 0.0 0.0 -15.2178355751 0.0 0.0 -15.2199042933 0.0 0.0 -15.2299042933 0.0 0.0 -15.2399042933 0.0 0.0 -15.2499042933 0.0 0.0 -15.2538932703 0.0 0.0 -15.2622086186 0.0 0.0 -15.2690090388 0.0 0.0 -15.2736822333 0.0 0.0 -15.2785219513 0.0 0.0 -15.2868736864 0.0 0.0 -15.2941489754 0.0 0.0 -15.2997584118 0.0 0.0 -15.3029505796 0.0 0.0 -15.3042913798 0.0 0.0 -15.3072382109 0.0 0.0 -15.3116363754 0.0 0.0 -15.3147595282 0.0 0.0 -15.3199226252 0.0 0.0 -15.3272506577 0.0 0.0 -15.3372506577 0.0 0.0 -15.34080942 0.0 0.0 -15.345204321 0.0 0.0 -15.3478673128 0.0 0.0 -15.3489717218 0.0 0.0 -15.3546263889 0.0 0.0 -15.3630741124 0.0 0.0 -15.3643874696 0.0 0.0 -15.3667180968 0.0 0.0 -15.3718081478 0.0 0.0 -15.3750187709 0.0 0.0 -15.3800601092 0.0 0.0 -15.3868383206 0.0 0.0 -15.391699631 0.0 0.0 -15.3954064174 0.0 0.0 -15.3994572439 0.0 0.0 -15.4043667753 0.0 0.0 -15.4105914336 0.0 0.0 -15.4190051849 0.0 0.0 -15.428077032 0.0 0.0 -15.4307586272 0.0 0.0 -15.4344739999 0.0 0.0 -15.4425325038 0.0 0.0 -15.4453297163 0.0 0.0 -15.4465262582 0.0 0.0 -15.447969735 0.0 0.0 -15.449512492 0.0 0.0 -15.4508357048 -225.646352172 0.0 -15.4527493157 471.701545896 0.0 -15.4556353243 711.264333939 0.0 -15.4578215801 1329.38388659 0.0 -15.4595808241 2870.6826653 0.0 -15.4619529311 3491.63874215 0.0 -15.4643936641 3171.84425072 0.0 -15.466856762 3677.0332256 0.0 -15.4710324275 4127.86460178 0.0 -15.4763825397 1968.52536201 0.0 -15.4807825354 688.534084112 0.0 -15.4847212863 1358.2779918 0.0 -15.4886275972 1455.59200081 0.0 -15.4939680205 1321.51313883 0.0 -15.4993239423 1205.03703574 0.0 -15.5040781434 971.581179875 0.0 -15.5087926338 823.409937844 0.0 -15.5156845371 787.735022077 0.0 -15.5244159234 790.003550585 0.0 -15.5306168737 769.070507752 0.0 -15.5360346465 752.431830673 0.0 -15.542267533 743.414737398 0.0 -15.5484818662 733.108873049 0.0 -15.5561458967 736.797380461 0.264631939469 -15.5661458967 754.358463554 0.0 -15.5684360312 759.597713346 0.0 -15.5717322965 763.424628699 0.0 -15.5812537815 775.974956466 0.0 -15.5912537815 779.064851763 -0.96565001509 -15.6012537815 773.264464789 0.147733164164 -15.6070164483 739.504202486 4.43161385172 -15.6151438495 728.372728658 6.89285889967 -15.6251438495 731.786259706 6.90514451428 -15.6351438495 736.584322176 5.74552797146 -15.6451438495 743.327743501 6.82288832969 -15.6551438495 753.825938243 7.76567823845 -15.6592576692 753.242347701 9.20709229213 -15.6635472902 757.696786184 9.43553904477 -15.6667879582 765.388143659 9.59148368317 -15.6711445509 776.756757912 0.0 -15.6784770077 793.468874703 0.0 -15.6884770077 814.506310194 0.0 -15.6966831028 838.125057084 0.0 -15.697792253 892.820611095 0.0 -15.707792253 902.812952174 0.0 -15.717792253 919.944191867 7.24471739114 -15.727792253 934.951164943 7.25480602975 -15.737792253 946.584035684 5.72537431922 -15.7438861411 953.749454587 5.43866270023 -15.7443861411 931.372104078 7.2998619032 -15.749567247 955.738004 3.96772824625 -15.7585472107 986.973903752 4.00990951116 -15.7665224458 1015.52850654 0.0 -15.7748118533 1040.56387204 9.82050965075 -15.7833870283 1059.35189101 -9.39427162358 -15.7909775484 1070.19461701 2.52598767827 -15.798359188 1080.1719141 1.65596179731 -15.8039275517 1077.19258757 0.0 -15.8091352389 1066.95685331 0.0 -15.816011703 1054.35751774 0.0 -15.8232110238 1059.63359701 0.0 -15.8296489706 1031.8771268 0.0 -15.835949523 1008.38624563 0.0 -15.8421878576 988.521770733 0.0 -15.8471606933 977.290452048 0.0 -15.8530886007 961.403965304 0.0 -15.8589804048 943.49084855 0.0 -15.8645160199 919.561147161 0.0 -15.8681642755 1031.23465959 0.0 -15.8716490658 986.336944562 0.0 -15.8761479294 984.105477033 0.0 -15.8810655892 994.533527925 0.0 -15.8857227563 1012.13990117 0.0 -15.8893771346 1003.85696546 0.0 -15.8944493098 1022.25023424 0.0 -15.9029560005 999.000375859 0.0 -15.9045014491 916.044989004 0.0 -15.9050014491 852.057387917 0.0 -15.9114109032 860.509465254 0.0 -15.9172755837 862.203561864 0.0 -15.9219623019 840.260497283 0.0 -15.9274144671 841.398322748 -0.819339413994 -15.9328861618 824.22017384 0.662295491866 -15.9378366109 795.228194609 0.0 -15.9426575194 823.497818669 0.0 -15.945941656 826.224164935 0.0 -15.9489865179 873.160795438 0.0 -15.9535924992 884.188979359 0.0 -15.957884265 883.564015149 -2.53923398725 -15.9620052489 864.693409898 -0.0372540183645 -15.9661296182 839.492275811 1.33479875603 -15.9702636672 819.940926279 0.0 -15.9740555634 798.3015562 0.0 -15.9777800393 780.621127455 0.0 -15.9815747343 778.390262294 0.0 -15.9830028245 770.28633589 0.0 -15.9865959922 839.564291867 0.0 -15.9903795114 849.761588797 0.0 -15.9937350315 808.615276392 0.0 -15.9957468701 809.880642275 0.0 -15.9990044714 808.477530606 0.0 -16.0022086445 807.706485552 0.0 -16.0055508567 814.533087906 0.0 -16.0088139327 813.898752587 0.0 -16.0118737329 816.174379196 0.0 -16.0138795111 821.343667176 0.0 -16.0168989698 820.187438874 0.0 -16.0198884254 816.018954056 0.0 -16.0216909259 809.927708859 0.0 -16.0246168692 803.969237129 0.0 -16.0277978361 801.538126923 0.0 -16.0304834853 930.80919284 0.0 -16.0334674245 854.666953308 0.0 -16.0389237184 801.117582032 0.0 -16.0460755139 786.429095634 0.0 -16.0525138354 765.71218962 0.0 -16.0607729207 743.457665015 0.0 -16.0694187578 731.268681908 0.0 -16.0794187578 726.000478556 0.0 -16.0894187578 718.689171935 0.0 -16.0994187578 719.122586917 0.0 -16.1032716552 729.461067207 0.0 -16.1132716552 730.875914696 0.0 -16.1187267674 722.204650799 0.0 -16.1287267674 710.60905104 0.0 -16.1387267674 696.120781526 0.0 -16.1449674572 709.615563363 0.0 -16.1481503526 709.639672912 0.0 -16.1491647336 756.992127657 0.0 -16.1496647336 706.065335362 0.0 -16.1501647336 686.424367067 0.0 -16.1507638198 709.18389665 0.0 -16.1512638198 716.861456392 0.0 -16.1517638198 731.147602305 0.0 -16.1536251471 749.017585012 0.0 -16.1541251471 724.95153749 0.0 -16.1641251471 691.657294958 0.0 -16.1741251471 690.760272246 0.0 -16.1809044779 671.721146234 0.0 -16.1909044779 651.722240277 0.0 -16.2009044779 640.982190709 0.0 -16.2109044779 621.483767628 0.0 -16.2130168447 589.528773542 0.0 -16.2230168447 584.171101939 0.0 -16.2330168447 586.272474474 0.0 -16.2430168447 570.901770008 0.0 -16.2530168447 558.19244789 0.0 -16.2612928893 569.626502771 0.0 -16.2712928893 553.633245175 0.0 -16.2812928893 548.887845336 0.0 -16.2912928893 538.393847716 0.0 -16.296968778 536.613739562 0.0 -16.2996716305 544.998944391 0.0 -16.3096716305 532.076529985 0.0 -16.3196716305 511.405997806 0.0 -16.3296716305 487.325725354 0.0 -16.333896272 469.8425243 0.0 -16.343896272 442.724353924 0.0 -16.353896272 429.248395882 0.0 -16.363896272 400.896876301 0.0 -16.373896272 380.71097298 0.0 -16.3830496553 360.858824003 0.0 -16.3930496553 342.918398121 0.0 -16.3995646034 332.254696174 0.0 -16.4095646034 300.471801657 0.0 -16.4139000675 321.938785139 0.0 -16.4239000675 263.772085379 0.0 -16.4308441968 288.429906984 0.0 -16.4334472414 281.725066301 0.0 -16.4357660465 272.708534949 0.0 -16.438644221 261.132510796 0.0 -16.4430850786 249.705459819 0.0 -16.4501103493 233.207698649 0.0 -16.4589479404 206.941046366 0.0 -16.4647809081 229.823986844 0.0 -16.4714049335 212.291742465 0.0 -16.4784675396 197.431868245 0.0 -16.4856359677 179.820365676 0.0 -16.4928308155 163.218972345 0.0 -16.5006103794 145.474347408 0.0 -16.5082749791 124.749435829 0.0 -16.5158664238 113.290373284 0.0 -16.5234052721 109.279869045 0.0 -16.5311519052 109.585715911 0.0 -16.5390948934 89.8154903846 0.0 -16.5479273887 87.7292403247 0.0 -16.5567979163 76.6564870372 0.0 -16.5589175353 78.8554881105 0.0 -16.561358418 74.1740717686 0.0 -16.5631664501 36.6054970018 0.0 -16.566133116 44.9801475723 0.0 -16.5702703304 61.1807307447 0.0 -16.5775734267 47.7854192461 0.0 -16.5866887325 12.2074588136 0.0 -16.5957039718 31.0661970693 0.0 -16.6057039718 18.3364235935 0.0 -16.6157039718 3.75447242444 0.0 -16.6257039718 -30.2571603535 0.0 -16.6357039718 1.2468314107 0.0 -16.644486775 -48.8023582833 0.0 -16.6524278927 -60.8101253448 0.0 -16.65336968 -74.7406496902 0.0 -16.6542980737 -67.1015985417 0.0 -16.6552875186 -64.3428081552 0.0 -16.6567504815 -63.421752097 0.0 -16.6590071872 -63.7570149108 0.0 -16.6626274457 -64.9868900058 0.0 -16.6655301987 -41.9344445777 0.0 -16.6702603977 -63.0248066003 0.0 -16.6740514221 -39.6409743299 0.0 -16.678168111 -40.4556684933 0.0 -16.6818283913 -35.9168579276 0.0 -16.6868903921 0.0 0.0 -16.6930469514 0.0 0.0 -16.698119266 0.0 0.0 -16.7033860716 0.0 0.0 -16.7093975656 0.0 0.0 -16.7163112168 0.0 0.0 -16.7228392917 0.0 0.0 -16.7290498421 0.0 0.0 -16.7351433445 0.0 0.0 -16.7410499889 0.0 0.0 -16.7465261843 0.0 0.0 -16.7526749226 0.0 0.0 -16.7592165059 0.0 0.0 -16.7656273118 0.0 0.0 -16.7714260519 0.0 0.0 -16.7770725062 0.0 0.0 -16.7787655038 0.0 0.0 -16.7849413246 0.0 0.0 -16.7925054061 0.0 0.0 -16.7994393738 0.0 0.0 -16.8002591573 0.0 0.0 -16.8069148803 0.0 0.0 -16.8121279359 0.0 0.0 -16.8140172367 0.0 0.0 -16.8187467012 0.0 0.0 -16.8232594138 0.0 0.0 -16.8252212767 0.0 0.0 -16.8275002405 0.0 0.0 -16.8289175872 0.0 0.0 -16.8323761334 0.0 0.0 -16.8357027336 0.0 0.0 -16.8371168679 0.0 0.0 -16.8404102582 0.0 0.0 -16.8463236181 0.0 0.0 -16.8512730582 0.0 0.0 -16.8571568544 0.0 0.0 -16.8618683131 0.0 0.0 -16.8696449147 0.0 0.0 -16.8776206764 0.0 0.0 -16.8876206764 0.0 0.0 -16.8976206764 0.0 0.0 -16.9063041429 0.0 0.0 -16.911835554 0.0 0.0 -16.9186992163 0.0 0.0 -16.927927835 0.0 0.0 -16.933973834 0.0 0.0 -16.9420405554 0.0 0.0 -16.9435904334 0.0 0.0 -16.9449894286 0.0 0.0 -16.951053867 0.0 0.0 -16.9571909057 0.0 0.0 -16.9594634188 0.0 0.0 -16.9633299426 0.0 0.0 -16.9702619658 0.0 0.0 -16.9755107254 0.0 0.0 -16.9817793173 0.0 0.0 -16.9872898277 0.0 0.0 -16.991098295 0.0 0.0 -16.9938461641 0.0 0.0 -17.0013034177 0.0 0.0 -17.0113034177 0.0 0.0 -17.0213034177 0.0 0.0 -17.0313034177 0.0 0.0 -17.0413034177 0.0 0.0 -17.0480051068 0.0 0.0 -17.0511987605 0.0 0.0 -17.0611987605 0.0 0.0 -17.0711987605 0.0 0.0 -17.0796538698 0.0 0.0 -17.087402593 0.0 0.0 -17.0938052822 0.0 0.0 -17.0983755444 0.0 0.0 -17.1023966589 0.0 0.0 -17.1067744054 0.0 0.0 -17.1111516711 0.0 0.0 -17.1157057849 0.0 0.0 -17.1192212852 0.0 0.0 -17.1263455232 0.0 0.0 -17.1334890811 0.0 0.0 -17.1379406989 0.0 0.0 -17.1433139055 0.0 0.0 -17.1481776606 0.0 0.0 -17.1541286397 0.0 0.0 -17.1601740446 0.0 0.0 -17.1680377124 0.0 0.0 -17.1695247223 0.0 0.0 -17.1701500849 0.0 0.0 -17.1719609263 0.0 0.0 -17.1819609263 0.0 0.0 -17.1828577975 0.0 0.0 -17.1843775763 0.0 0.0 -17.1901943872 0.0 0.0 -17.1976532091 0.0 0.0 -17.1985288947 0.0 0.0 -17.2000297559 0.0 0.0 -17.2027917089 0.0 0.0 -17.2083489984 0.0 0.0 -17.2160473801 0.0 0.0 -17.2230472945 0.0 0.0 -17.2285232818 0.0 0.0 -17.2346527787 0.0 0.0 -17.2443683131 0.0 0.0 -17.2509504716 0.0 0.0 -17.2585880591 0.0 0.0 -17.263727503 0.0 0.0 -17.273727503 0.0 0.0 -17.2745546825 0.0 0.0 -17.2757356365 0.0 0.0 -17.2833704943 0.0 0.0 -17.2888249042 0.0 0.0 -17.2939420673 0.0 0.0 -17.2969621582 0.0 0.0 -17.3019343252 0.0 0.0 -17.3053827563 0.0 0.0 -17.3089820257 0.0 0.0 -17.3105945843 0.0 0.0 -17.3120360625 0.0 0.0 -17.3131557968 0.0 0.0 -17.3169012444 0.0 0.0 -17.3203735573 0.0 0.0 -17.3221749242 0.0 0.0 -17.3316930818 0.0 0.0 -17.3406719363 0.0 0.0 -17.3452490732 738.74734083 0.0 -17.3468600534 1039.4150601 0.0 -17.3486108356 1447.70478375 0.0 -17.3494441961 1411.02633262 0.0 -17.3508557611 818.114197438 0.0 -17.3562465306 1251.90274871 0.0 -17.3598277442 2529.86088905 0.0 -17.3614069525 2433.24291481 0.0 -17.3673526458 1976.8980987 0.0 -17.3697976967 1433.51646201 0.0 -17.3768885794 1381.23028804 0.0 -17.3856448503 1094.03717 0.0 -17.3888338678 777.243734252 0.0 -17.3944110683 677.67128547 0.0 -17.3978271533 705.704477754 0.0 -17.4018890242 739.780862683 0.0 -17.4091636469 817.828790174 0.0 -17.4159106447 893.323195173 0.0 -17.4232431695 893.890083552 0.0 -17.4243729315 918.749321272 0.0 -17.4324757223 879.913865949 -0.789656289195 -17.4368878717 810.507064625 0.0 -17.4410599149 751.231943685 0.0 -17.4466016875 725.74729493 0.0 -17.4530763114 723.658264618 0.0 -17.4604066581 728.507581781 0.0 -17.4695924379 732.684432137 0.0 -17.4771440623 727.620260084 0.0 -17.4863314539 727.690103067 0.0 -17.4963314539 727.717069731 0.0 -17.5063314539 715.652567842 0.0 -17.5163314539 710.511980275 0.0 -17.5263314539 709.745872318 0.0 -17.5363314539 715.665790703 0.0 -17.5463314539 726.223166829 0.0 -17.5563314539 741.096222283 11.4719034984 -17.5663314539 759.103601666 22.3829790352 -17.5763314539 781.9134573 19.0836277125 -17.5863314539 808.09292783 -4.6378214438 -17.5955445913 833.527518455 7.7712629201 -17.6055445913 858.029886242 8.09246187866 -17.6155445913 886.752104429 9.54026332311 -17.6233650579 915.744682647 9.80615979236 -17.6265214158 958.268985178 10.1674640574 -17.6365214158 980.374740027 0.0 -17.6465214158 1002.21680002 0.0 -17.6565214158 1017.64217115 0.0 -17.662495193 1034.9261114 0.0 -17.672495193 1044.94704578 0.0 -17.682495193 1051.28798222 0.0 -17.6914200218 1060.39990773 0.0 -17.6987352525 1060.06452202 0.0 -17.7087352525 1058.52217376 2.56497784723 -17.7173721892 1038.8537071 2.98489820378 -17.7254287951 1025.77480473 5.5230904524 -17.7326148503 1015.54604601 6.86802923194 -17.7393105816 970.296088016 7.59160473417 -17.7451418945 984.305584393 0.0 -17.7500057116 931.928970737 0.713885125494 -17.7548784116 956.87874678 0.555837198624 -17.7597523479 887.943127531 -0.515183273992 -17.7642698871 869.988484905 -0.346774162976 -17.7681623261 857.953718068 0.0 -17.7718219102 857.017976637 0.0 -17.7754029244 843.551568897 0.0 -17.7789020362 834.973730011 0.0 -17.7823604906 826.921568777 0.0 -17.7857398328 823.248450709 0.0 -17.7890921454 878.1095692 0.0 -17.7924537809 904.691680501 0.0 -17.7958862866 1032.08166806 0.0 -17.7995040238 1010.55226624 0.0 -17.8027579001 1022.29687594 0.0 -17.8057966574 1077.10815292 0.0 -17.8086857323 1028.09383775 0.0 -17.811502927 1024.09282124 0.0 -17.812002927 1210.55398237 0.0 -17.8125421312 1246.51961392 0.0 -17.8154254614 1204.42413745 0.0 -17.8183379384 1118.59948773 0.0 -17.8213424705 1031.53660832 0.0 -17.8246836024 1034.59938847 0.0 -17.8281811915 951.203290157 0.0 -17.8327557318 888.657777525 0.0 -17.8374958461 921.121513464 0.0 -17.8407630541 943.559316061 0.0 -17.8442937359 848.451944024 0.0 -17.8474855267 859.939727562 0.0 -17.8521269774 791.31625721 0.0 -17.8568882141 821.382125206 0.0 -17.8623998356 817.779167571 0.0 -17.8702388037 819.952525295 0.0 -17.8771859053 766.40924177 0.0 -17.8832980462 743.840067996 0.0 -17.8932980462 733.826095525 0.0 -17.8955830815 730.418636404 0.0 -17.9055830815 729.896574721 0.0 -17.9155830815 762.524830948 0.0 -17.9255830815 789.759580385 0.0 -17.9355830815 815.764928316 0.0 -17.9455830815 837.640476069 0.0 -17.9555830815 833.717905805 0.0 -17.9655830815 814.519133037 0.0 -17.9753734728 830.095928803 0.0 -17.9850715084 814.177066483 0.0 -17.9950715084 799.56836297 0.0 -18.0007411076 802.323947022 0.0 -18.0107411076 789.618243413 0.0 -18.0207411076 774.690960809 0.0 -18.024439334 756.988536756 0.0 -18.034439334 742.747539175 0.0 -18.044439334 727.969129703 0.0 -18.054439334 711.329865812 0.0 -18.0612584216 710.209067643 0.0 -18.0712584216 697.173384314 0.0 -18.0812584216 687.843313399 0.0 -18.0912584216 677.152652911 0.0 -18.1012584216 661.257574085 0.0 -18.1112584216 638.39787112 0.0 -18.1212584216 611.306344669 0.0 -18.1298880913 603.119308674 0.0 -18.1398880913 608.137326492 0.0 -18.1498880913 608.283381604 0.0 diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_coarse.csv b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_coarse.csv deleted file mode 100644 index 87d5e75bb8b1..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_coarse.csv +++ /dev/null @@ -1,2386 +0,0 @@ -time (0.0,0.093) (0.0,0.299) -1e-06 0.0 0.0 -2e-06 0.0 0.0 -3e-06 0.0 0.0 -0.010003 8.27538650696 0.0 -0.020003 41.4716580454 0.0 -0.030003 59.0980959309 0.0 -0.040003 65.1779478114 0.0 -0.050003 67.9921113147 0.0 -0.0638799142749 76.4851395006 0.0 -0.0738799142749 80.2364815453 0.0 -0.0838799142749 84.1840154999 0.0 -0.0938799142749 84.4571984601 0.0 -0.103879914275 84.9443901157 0.0 -0.113879914275 83.058509134 0.0 -0.123879914275 82.1459754251 0.0 -0.133879914275 81.3267644996 0.0 -0.143879914275 81.178107307 0.0 -0.153879914275 80.9920712387 0.0 -0.163879914275 80.4723744668 0.0 -0.173879914275 80.1332029453 0.0 -0.183879914275 80.2542017782 0.0 -0.193879914275 81.0988495136 0.0 -0.203879914275 82.9041108354 0.0 -0.213879914275 85.8304562403 0.0 -0.223879914275 88.5060788073 0.0 -0.233879914275 90.7666152889 0.0 -0.243879914275 93.208793258 0.0 -0.253879914275 99.4974892429 0.0 -0.263879914275 104.520276318 0.0 -0.273879914275 107.553964702 0.0 -0.283879914275 111.954689278 0.0 -0.293879914275 116.194294484 0.0 -0.303879914275 119.582772088 0.0 -0.313879914275 123.438828994 0.0 -0.323879914275 127.373361752 0.0 -0.333879914275 131.018141039 0.0 -0.343879914275 134.307207304 0.0 -0.353879914275 137.470591117 0.0 -0.363879914275 146.441517656 0.0 -0.373879914275 148.492430766 0.0 -0.383879914275 152.224555483 0.0 -0.393879914275 156.666822352 0.0 -0.403879914275 161.452080477 0.0 -0.413879914275 166.612111666 0.0 -0.423879914275 171.711152474 0.0 -0.433879914275 177.336697284 0.0 -0.443879914275 183.397988933 0.0 -0.453879914275 189.739339122 0.0 -0.463879914275 196.182888008 0.0 -0.473879914275 203.058183361 0.0 -0.483879914275 210.437850211 0.0 -0.493879914275 215.255345517 0.0 -0.503879914275 222.373383104 0.0 -0.513879914275 232.751100704 0.0 -0.523879914275 242.128579718 0.0 -0.533879914275 249.442201886 0.0 -0.543879914275 256.848027386 0.0 -0.553879914275 265.257544999 0.0 -0.563879914275 269.361880627 0.0 -0.573879914275 273.610596421 0.0 -0.583879914275 276.846465031 0.0 -0.593879914275 272.471179938 0.0 -0.603879914275 276.336060753 0.0 -0.613879914275 279.446752392 0.0 -0.623879914275 283.940643048 0.0 -0.633879914275 289.511916498 0.0 -0.643879914275 290.840139816 0.0 -0.653879914275 294.180153413 0.0 -0.663879914275 295.392056277 0.0 -0.673879914275 295.691529267 0.0 -0.683879914275 299.811214135 0.0 -0.693879914275 299.895542229 0.0 -0.703879914275 302.587590795 0.0 -0.713879914275 301.598047326 0.0 -0.723879914275 304.772361872 0.0 -0.733879914275 305.18460055 0.0 -0.743879914275 307.520542318 0.0 -0.753879914275 307.969794811 0.0 -0.763879914275 310.102710719 0.0 -0.773879914275 311.744535418 0.0 -0.783879914275 311.257422943 0.0 -0.793879914275 311.681568913 0.0 -0.803879914275 313.162368444 0.0 -0.813879914275 313.815018907 0.0 -0.823879914275 313.478015728 0.0 -0.833879914275 313.783351348 0.0 -0.843879914275 314.494385486 0.0 -0.853879914275 315.619523946 0.0 -0.863879914275 315.912629757 0.0 -0.873879914275 315.647995556 0.0 -0.883879914275 315.526105788 0.0 -0.893879914275 316.210662117 0.0 -0.903879914275 315.014060534 0.0 -0.913879914275 313.024107375 0.0 -0.923879914275 310.246594999 0.0 -0.935515243612 307.828601966 0.0 -0.952430863257 302.094428056 0.0 -0.962430863257 285.365999038 0.0 -0.972430863257 262.41899573 0.0 -0.982430863257 244.971290869 0.0 -0.992430863257 247.223483981 0.0 -1.00243086326 242.50671212 0.0 -1.01243086326 238.573974299 0.0 -1.02243086326 231.625658998 0.0 -1.03243086326 222.791761557 0.0 -1.04243086326 212.77329213 0.0 -1.05243086326 202.421299473 0.0 -1.06243086326 192.519343423 0.0 -1.07243086326 182.993303533 0.0 -1.08243086326 174.56388137 0.0 -1.09243086326 167.102632215 0.0 -1.10243086326 160.170155204 0.0 -1.11243086326 157.252372315 0.0 -1.12243086326 153.805803077 0.0 -1.13243086326 146.630494129 0.0 -1.14243086326 138.754826944 0.0 -1.15243086326 133.787520773 0.0 -1.16243086326 130.916148923 0.0 -1.17243086326 130.230723137 0.0 -1.18243086326 128.921579897 0.0 -1.19243086326 128.180900653 0.0 -1.20243086326 125.650650963 0.0 -1.21243086326 124.443148117 0.0 -1.22243086326 122.385385982 0.0 -1.23243086326 115.326084034 0.0 -1.24243086326 107.405185207 0.0 -1.25243086326 97.6890712554 0.0 -1.26243086326 70.7551919798 0.0 -1.27243086326 49.895095222 0.0 -1.28243086326 30.5084649987 0.0 -1.29243086326 12.2490797682 0.0 -1.30243086326 2.4743175472 0.0 -1.31243086326 -12.0661897868 0.0 -1.32243086326 -13.5613003608 0.0 -1.33243086326 -6.37998306881 0.0 -1.34243086326 -3.42244572869 0.0 -1.35243086326 -68.8646568064 0.0 -1.36243086326 -42.4691616196 0.0 -1.37243086326 -58.8812210937 0.0 -1.38243086326 -74.5152646798 0.0 -1.39243086326 -85.2849452828 0.0 -1.40243086326 -108.665236434 0.0 -1.41243086326 -114.62389122 0.0 -1.42243086326 -115.557463042 0.0 -1.43243086326 -95.1661701322 0.0 -1.44243086326 -66.5279077945 0.0 -1.45243086326 -38.8692625212 0.0 -1.46243086326 -109.894096503 0.0 -1.47243086326 -125.023766621 0.0 -1.48243086326 -128.040068352 0.0 -1.49243086326 -124.953282122 0.0 -1.50243086326 -127.09138657 0.0 -1.51243086326 -88.7003100086 0.0 -1.52243086326 -115.447128205 0.0 -1.53243086326 -54.5077401318 0.0 -1.54243086326 -54.5077401318 0.0 -1.55243086326 -54.5077401318 0.0 -1.56243086326 -54.5077401318 0.0 -1.57243086326 -54.5077401318 0.0 -1.58243086326 -54.5077401318 0.0 -1.59243086326 -54.5077401318 0.0 -1.60243086326 -54.5077401318 0.0 -1.61243086326 -54.5077401318 0.0 -1.62243086326 -54.5077401318 0.0 -1.63243086326 -54.5077401318 0.0 -1.64243086326 -54.5077401318 0.0 -1.65243086326 -54.5077401318 0.0 -1.66243086326 -54.5077401318 0.0 -1.67243086326 -54.5077401318 0.0 -1.68243086326 -54.5077401318 0.0 -1.69243086326 -54.5077401318 0.0 -1.70243086326 -54.5077401318 0.0 -1.71243086326 -54.5077401318 0.0 -1.72243086326 -54.5077401318 0.0 -1.73243086326 -54.5077401318 0.0 -1.74243086326 -54.5077401318 0.0 -1.75243086326 -54.5077401318 0.0 -1.76243086326 -54.5077401318 0.0 -1.77243086326 -54.5077401318 0.0 -1.78243086326 -54.5077401318 0.0 -1.79243086326 -54.5077401318 0.0 -1.80243086326 -54.5077401318 0.0 -1.81243086326 -54.5077401318 0.0 -1.82243086326 -54.5077401318 0.0 -1.83243086326 -54.5077401318 0.0 -1.84243086326 -54.5077401318 0.0 -1.85243086326 -54.5077401318 0.0 -1.86243086326 -54.5077401318 0.0 -1.87243086326 -54.5077401318 0.0 -1.88243086326 -54.5077401318 0.0 -1.89243086326 -54.5077401318 0.0 -1.90243086326 -54.5077401318 0.0 -1.91243086326 -54.5077401318 0.0 -1.92243086326 -54.5077401318 0.0 -1.93243086326 -54.5077401318 0.0 -1.94243086326 -54.5077401318 0.0 -1.95243086326 -54.5077401318 0.0 -1.96243086326 -54.5077401318 0.0 -1.97243086326 -54.5077401318 0.0 -1.98243086326 -54.5077401318 0.0 -1.99243086326 -54.5077401318 0.0 -2.00243086326 -54.5077401318 0.0 -2.01243086326 -54.5077401318 0.0 -2.02243086326 -54.5077401318 0.0 -2.03243086326 -54.5077401318 0.0 -2.04243086326 -54.5077401318 0.0 -2.05243086326 -54.5077401318 0.0 -2.06243086326 -54.5077401318 0.0 -2.07243086326 -54.5077401318 0.0 -2.08243086326 -54.5077401318 0.0 -2.09243086326 -54.5077401318 0.0 -2.10243086326 -54.5077401318 0.0 -2.11243086326 -54.5077401318 0.0 -2.12243086326 -54.5077401318 0.0 -2.13243086326 -54.5077401318 0.0 -2.14243086326 -54.5077401318 0.0 -2.15243086326 -54.5077401318 0.0 -2.16243086326 -54.5077401318 0.0 -2.17243086326 -54.5077401318 0.0 -2.18243086326 -54.5077401318 0.0 -2.19243086326 -54.5077401318 0.0 -2.20243086326 -54.5077401318 0.0 -2.21243086326 -54.5077401318 0.0 -2.22243086326 -54.5077401318 0.0 -2.23243086326 -54.5077401318 0.0 -2.24243086326 -54.5077401318 0.0 -2.25243086326 -54.5077401318 0.0 -2.26243086326 -54.5077401318 0.0 -2.27243086326 -54.5077401318 0.0 -2.28243086326 -54.5077401318 0.0 -2.29243086326 -54.5077401318 0.0 -2.30243086326 -54.5077401318 0.0 -2.31243086326 -54.5077401318 0.0 -2.32243086326 -54.5077401318 0.0 -2.33243086326 -54.5077401318 0.0 -2.34243086326 -54.5077401318 0.0 -2.35243086326 -42.23846659 0.0 -2.36243086326 -27.5965234239 0.0 -2.37243086326 -3.901048091 0.0 -2.38243086326 24.9964745484 0.0 -2.39243086326 161.558752479 0.0 -2.40243086326 303.908640109 0.0 -2.41243086326 447.578778892 0.0 -2.42243086326 643.191774072 0.0 -2.43243086326 898.919477283 0.0 -2.44243086326 1138.39517584 0.0 -2.45243086326 1297.07148755 0.0 -2.46243086326 1316.9993017 0.0 -2.47243086326 1255.85568947 0.0 -2.48243086326 1102.32539316 0.0 -2.49243086326 940.713816444 0.0 -2.50243086326 830.086581248 0.0 -2.51243086326 740.007456556 0.0 -2.52243086326 645.679709129 0.0 -2.53243086326 596.890423339 0.0 -2.54243086326 530.792637263 0.0 -2.55243086326 497.649822699 0.0 -2.56243086326 477.747563361 0.0 -2.57243086326 469.695017279 0.0 -2.58243086326 470.974112452 0.0 -2.59243086326 493.001053136 65.2282941559 -2.60243086326 522.570249196 62.3583211653 -2.61243086326 561.675317596 70.368251793 -2.62243086326 599.446812239 23.6295001206 -2.63243086326 642.661179903 31.1935014532 -2.64243086326 694.036791282 31.458578886 -2.65243086326 741.873171554 31.458578886 -2.66243086326 794.836633329 31.458578886 -2.67243086326 842.578631453 31.458578886 -2.68243086326 889.332936184 31.458578886 -2.69243086326 941.290851403 31.458578886 -2.70243086326 962.559343362 31.458578886 -2.71243086326 965.233896099 31.458578886 -2.72243086326 972.447758598 31.458578886 -2.73243086326 955.716089159 31.458578886 -2.74243086326 920.873753159 31.458578886 -2.75243086326 899.225780267 31.458578886 -2.76243086326 953.248855378 31.458578886 -2.77243086326 841.726106242 31.458578886 -2.78243086326 749.178461591 31.458578886 -2.79243086326 663.422345982 31.458578886 -2.80243086326 593.298109143 31.458578886 -2.81243086326 528.848788868 31.458578886 -2.82243086326 475.827049868 31.458578886 -2.83243086326 435.809012162 31.458578886 -2.84243086326 404.76396253 31.458578886 -2.85243086326 372.608568509 31.458578886 -2.86243086326 347.824193093 31.458578886 -2.87243086326 326.436266552 31.458578886 -2.88243086326 305.235949409 31.458578886 -2.89243086326 290.36384054 31.458578886 -2.90243086326 277.257074509 31.458578886 -2.91243086326 268.872597458 31.458578886 -2.92243086326 259.022009348 31.458578886 -2.93243086326 253.575640417 31.458578886 -2.94243086326 242.934937715 31.458578886 -2.95243086326 227.093688993 31.458578886 -2.96243086326 223.021011542 31.458578886 -2.97243086326 221.304330364 31.458578886 -2.98243086326 213.30718276 31.458578886 -2.99243086326 212.90047382 31.458578886 -3.00243086326 212.837951811 31.458578886 -3.01243086326 213.20432017 31.458578886 -3.02243086326 211.384908963 31.458578886 -3.03243086326 214.693027172 31.458578886 -3.04243086326 210.665986269 31.458578886 -3.05243086326 208.948341377 31.458578886 -3.06243086326 202.397797373 31.458578886 -3.07243086326 183.110773808 31.458578886 -3.08243086326 178.673949095 31.458578886 -3.09243086326 172.769786205 31.458578886 -3.10243086326 164.331118468 31.458578886 -3.11243086326 156.838201765 31.458578886 -3.12243086326 149.431019612 31.458578886 -3.13243086326 144.22460355 31.458578886 -3.14243086326 133.450002733 31.458578886 -3.15243086326 122.980578762 31.458578886 -3.16243086326 118.950470025 31.458578886 -3.17243086326 116.101647019 31.458578886 -3.18243086326 115.702751154 31.458578886 -3.19243086326 107.741006266 31.458578886 -3.20243086326 98.4458266406 31.458578886 -3.21243086326 88.8589768001 31.458578886 -3.22243086326 75.7578183449 31.458578886 -3.23243086326 66.2656302036 31.458578886 -3.24243086326 57.6702034583 31.458578886 -3.25243086326 41.7669323384 31.458578886 -3.26243086326 22.3856916605 31.458578886 -3.27243086326 7.06463005656 31.458578886 -3.28243086326 -7.97247602572 31.458578886 -3.29243086326 -33.6185669536 31.458578886 -3.30243086326 -57.2822298774 31.458578886 -3.31243086326 -76.8651910722 31.458578886 -3.32243086326 -97.5452739745 31.458578886 -3.33243086326 -110.793631199 31.458578886 -3.34243086326 -120.50818295 31.458578886 -3.35243086326 -120.50818295 31.458578886 -3.36243086326 -120.50818295 31.458578886 -3.37243086326 -120.50818295 31.458578886 -3.38243086326 -120.50818295 31.458578886 -3.39243086326 -120.50818295 31.458578886 -3.40243086326 -120.50818295 31.458578886 -3.41243086326 -120.50818295 31.458578886 -3.42243086326 -120.50818295 31.458578886 -3.43243086326 -120.50818295 31.458578886 -3.44243086326 -120.50818295 31.458578886 -3.45243086326 -120.50818295 31.458578886 -3.46243086326 -120.50818295 31.458578886 -3.47243086326 -120.50818295 31.458578886 -3.48243086326 -120.50818295 31.458578886 -3.49243086326 -120.50818295 31.458578886 -3.50243086326 -120.50818295 31.458578886 -3.51243086326 -120.50818295 31.458578886 -3.52243086326 -120.50818295 31.458578886 -3.53243086326 -120.50818295 31.458578886 -3.54243086326 -120.50818295 31.458578886 -3.55243086326 -120.50818295 31.458578886 -3.56243086326 -120.50818295 31.458578886 -3.57243086326 -120.50818295 31.458578886 -3.58243086326 -120.50818295 31.458578886 -3.59243086326 -120.50818295 31.458578886 -3.60243086326 -120.50818295 31.458578886 -3.61243086326 -120.50818295 31.458578886 -3.62243086326 -120.50818295 31.458578886 -3.63243086326 -120.50818295 31.458578886 -3.64243086326 -120.50818295 31.458578886 -3.65243086326 -120.50818295 31.458578886 -3.66243086326 -120.50818295 31.458578886 -3.67243086326 -120.50818295 31.458578886 -3.68243086326 -120.50818295 31.458578886 -3.69243086326 -120.50818295 31.458578886 -3.70243086326 -120.50818295 31.458578886 -3.71243086326 -120.50818295 31.458578886 -3.72243086326 -120.50818295 31.458578886 -3.73243086326 -120.50818295 31.458578886 -3.74243086326 -120.50818295 31.458578886 -3.75243086326 -120.50818295 31.458578886 -3.76243086326 -120.50818295 31.458578886 -3.77243086326 -120.50818295 31.458578886 -3.78243086326 -120.50818295 31.458578886 -3.79243086326 -120.50818295 31.458578886 -3.80243086326 -120.50818295 31.458578886 -3.81243086326 -120.50818295 31.458578886 -3.82243086326 -120.50818295 31.458578886 -3.83243086326 -120.50818295 31.458578886 -3.84243086326 -120.50818295 31.458578886 -3.85243086326 -120.50818295 31.458578886 -3.86243086326 -120.50818295 31.458578886 -3.87243086326 -120.50818295 31.458578886 -3.88243086326 -120.50818295 31.458578886 -3.89243086326 -120.50818295 31.458578886 -3.90243086326 -120.50818295 31.458578886 -3.91243086326 -120.50818295 31.458578886 -3.92243086326 -120.50818295 31.458578886 -3.93243086326 -120.50818295 31.458578886 -3.94243086326 -120.50818295 31.458578886 -3.95243086326 -120.50818295 31.458578886 -3.96243086326 -120.50818295 31.458578886 -3.97243086326 -120.50818295 31.458578886 -3.98243086326 -120.50818295 31.458578886 -3.99243086326 -120.50818295 31.458578886 -4.00243086326 -120.50818295 31.458578886 -4.01243086326 -120.50818295 31.458578886 -4.02243086326 -120.50818295 31.458578886 -4.03243086326 -120.50818295 31.458578886 -4.04243086326 -120.50818295 31.458578886 -4.05243086326 -120.50818295 31.458578886 -4.06243086326 -120.50818295 31.458578886 -4.07243086326 -120.50818295 31.458578886 -4.08243086326 -120.50818295 31.458578886 -4.09243086326 -120.50818295 31.458578886 -4.10243086326 -120.50818295 31.458578886 -4.11243086326 -120.50818295 31.458578886 -4.12243086326 -120.50818295 31.458578886 -4.13243086326 -120.50818295 31.458578886 -4.14243086326 -120.50818295 31.458578886 -4.15243086326 -120.50818295 31.458578886 -4.16243086326 -120.50818295 31.458578886 -4.17243086326 -120.50818295 31.458578886 -4.18243086326 -120.50818295 31.458578886 -4.19243086326 -120.50818295 31.458578886 -4.20243086326 -120.50818295 31.458578886 -4.21243086326 -120.50818295 31.458578886 -4.22243086326 -120.50818295 31.458578886 -4.23243086326 -120.50818295 31.458578886 -4.24243086326 -15.4393474719 31.458578886 -4.25243086326 46.534157914 31.458578886 -4.26243086326 189.063398258 31.458578886 -4.27243086326 339.266438255 31.458578886 -4.28243086326 531.851893031 31.458578886 -4.29243086326 764.884006793 31.458578886 -4.30243086326 897.432300575 31.458578886 -4.31243086326 971.47241896 31.458578886 -4.32243086326 1054.1757413 31.458578886 -4.33243086326 1058.41769734 31.458578886 -4.34243086326 1055.73425533 31.458578886 -4.35243086326 912.899110789 31.458578886 -4.36243086326 781.114172444 31.458578886 -4.37243086326 687.104268078 31.458578886 -4.38243086326 624.170770837 31.458578886 -4.39243086326 564.493997748 31.458578886 -4.40243086326 498.787873475 31.458578886 -4.41243086326 455.365982932 9.32875981843 -4.42243086326 427.071750969 9.35762286818 -4.43243086326 412.148212353 8.91675568699 -4.44243086326 409.814589381 8.78412915624 -4.45243086326 415.078036348 33.9794479547 -4.46243086326 424.715304957 31.5196963847 -4.47243086326 455.392774688 -31.945023889 -4.48243086326 495.264753462 13.0983742433 -4.49243086326 535.811587387 12.3910399633 -4.50243086326 580.98659515 22.9943168439 -4.51243086326 635.588730989 2.97611398154 -4.52243086326 677.72720011 14.9822750596 -4.53243086326 721.955639087 18.8007453059 -4.54243086326 754.681945502 20.99399568 -4.55243086326 778.940605592 20.99399568 -4.56243086326 798.704093804 20.99399568 -4.57243086326 811.045075967 20.99399568 -4.58243086326 812.628419403 20.99399568 -4.59243086326 795.239275317 20.99399568 -4.60243086326 767.113175576 20.99399568 -4.61243086326 740.117621252 20.99399568 -4.62243086326 676.76970825 20.99399568 -4.63243086326 620.709384974 20.99399568 -4.64243086326 684.663490301 20.99399568 -4.65243086326 641.201037063 20.99399568 -4.66243086326 603.847593832 20.99399568 -4.67243086326 504.320091704 20.99399568 -4.68243086326 547.276899186 20.99399568 -4.69243086326 451.776191016 20.99399568 -4.70243086326 371.000581821 20.99399568 -4.71243086326 329.892801152 20.99399568 -4.72243086326 287.882647308 20.99399568 -4.73243086326 279.928756273 20.99399568 -4.74243086326 310.02161951 20.99399568 -4.75243086326 326.721946773 20.99399568 -4.76243086326 329.145496655 20.99399568 -4.77243086326 327.609137112 20.99399568 -4.78243086326 315.006865689 20.99399568 -4.79243086326 308.436108758 20.99399568 -4.80243086326 306.177246899 20.99399568 -4.81243086326 309.40426003 20.99399568 -4.82243086326 320.369079102 20.99399568 -4.83243086326 308.49993555 20.99399568 -4.84243086326 319.361299681 20.99399568 -4.85243086326 336.130098939 20.99399568 -4.86243086326 345.26887183 20.99399568 -4.87243086326 356.800098731 20.99399568 -4.88243086326 363.489814022 20.99399568 -4.89243086326 365.941249075 20.99399568 -4.90243086326 377.678886738 20.99399568 -4.91243086326 365.146483452 20.99399568 -4.92243086326 357.621195494 20.99399568 -4.93243086326 357.363538415 20.99399568 -4.94243086326 356.742155549 20.99399568 -4.95243086326 346.782892092 20.99399568 -4.96243086326 338.611830644 20.99399568 -4.97243086326 326.655656565 20.99399568 -4.98243086326 312.444978356 20.99399568 -4.99243086326 289.653408004 20.99399568 -5.00243086326 277.38836724 20.99399568 -5.01243086326 257.721000091 20.99399568 -5.02243086326 240.323565226 20.99399568 -5.03243086326 227.014136836 20.99399568 -5.04243086326 212.610698835 20.99399568 -5.05243086326 202.62348044 20.99399568 -5.06243086326 188.793524965 20.99399568 -5.07243086326 176.563526882 20.99399568 -5.08243086326 162.306534569 20.99399568 -5.09243086326 150.7243095 20.99399568 -5.10243086326 142.484800276 20.99399568 -5.11243086326 132.661969398 20.99399568 -5.12243086326 123.625359885 20.99399568 -5.13243086326 111.96797972 20.99399568 -5.14243086326 97.8816480389 20.99399568 -5.15243086326 86.8199588314 20.99399568 -5.16243086326 78.9280412183 20.99399568 -5.17243086326 71.8281661327 20.99399568 -5.18243086326 59.9737392986 20.99399568 -5.19243086326 44.9327123989 20.99399568 -5.20243086326 28.4435666601 20.99399568 -5.21243086326 8.34546027352 20.99399568 -5.22243086326 -5.39889007021 20.99399568 -5.23243086326 -19.4961010292 20.99399568 -5.24243086326 -34.6450472642 20.99399568 -5.25243086326 -48.0074585541 20.99399568 -5.26243086326 -60.4712396511 20.99399568 -5.27243086326 -70.2682817574 20.99399568 -5.28243086326 -106.737040617 20.99399568 -5.29243086326 -131.369599917 20.99399568 -5.30243086326 -137.974592446 20.99399568 -5.31243086326 -137.204558149 20.99399568 -5.32243086326 -127.262183224 20.99399568 -5.33243086326 -104.478130768 20.99399568 -5.34243086326 -105.244558962 20.99399568 -5.35243086326 -105.244558962 20.99399568 -5.36243086326 -105.244558962 20.99399568 -5.37243086326 -105.244558962 20.99399568 -5.38243086326 -105.244558962 20.99399568 -5.39243086326 -105.244558962 20.99399568 -5.40243086326 -105.244558962 20.99399568 -5.41243086326 -105.244558962 20.99399568 -5.42243086326 -105.244558962 20.99399568 -5.43243086326 -105.244558962 20.99399568 -5.44243086326 -105.244558962 20.99399568 -5.45243086326 -105.244558962 20.99399568 -5.46243086326 -105.244558962 20.99399568 -5.47243086326 -105.244558962 20.99399568 -5.48243086326 -105.244558962 20.99399568 -5.49243086326 -105.244558962 20.99399568 -5.50243086326 -105.244558962 20.99399568 -5.51243086326 -105.244558962 20.99399568 -5.52243086326 -105.244558962 20.99399568 -5.53243086326 -105.244558962 20.99399568 -5.54243086326 -105.244558962 20.99399568 -5.55243086326 -105.244558962 20.99399568 -5.56243086326 -105.244558962 20.99399568 -5.57243086326 -105.244558962 20.99399568 -5.58243086326 -105.244558962 20.99399568 -5.59243086326 -105.244558962 20.99399568 -5.60243086326 -105.244558962 20.99399568 -5.61243086326 -105.244558962 20.99399568 -5.62243086326 -105.244558962 20.99399568 -5.63243086326 -105.244558962 20.99399568 -5.64243086326 -105.244558962 20.99399568 -5.65243086326 -105.244558962 20.99399568 -5.66243086326 -105.244558962 20.99399568 -5.67243086326 -105.244558962 20.99399568 -5.68243086326 -105.244558962 20.99399568 -5.69243086326 -105.244558962 20.99399568 -5.70243086326 -105.244558962 20.99399568 -5.71243086326 -105.244558962 20.99399568 -5.72243086326 -105.244558962 20.99399568 -5.73243086326 -105.244558962 20.99399568 -5.74243086326 -105.244558962 20.99399568 -5.75243086326 -105.244558962 20.99399568 -5.76243086326 -105.244558962 20.99399568 -5.77243086326 -105.244558962 20.99399568 -5.78243086326 -105.244558962 20.99399568 -5.79243086326 -105.244558962 20.99399568 -5.80243086326 -105.244558962 20.99399568 -5.81243086326 -105.244558962 20.99399568 -5.82243086326 -105.244558962 20.99399568 -5.83243086326 -105.244558962 20.99399568 -5.84243086326 -105.244558962 20.99399568 -5.85243086326 -105.244558962 20.99399568 -5.86243086326 -105.244558962 20.99399568 -5.87243086326 -105.244558962 20.99399568 -5.88243086326 -105.244558962 20.99399568 -5.89243086326 -105.244558962 20.99399568 -5.90243086326 -105.244558962 20.99399568 -5.91243086326 -105.244558962 20.99399568 -5.92243086326 -105.244558962 20.99399568 -5.93243086326 -105.244558962 20.99399568 -5.94243086326 -105.244558962 20.99399568 -5.95243086326 -105.244558962 20.99399568 -5.96243086326 -105.244558962 20.99399568 -5.97243086326 -105.244558962 20.99399568 -5.98243086326 -105.244558962 20.99399568 -5.99243086326 -105.244558962 20.99399568 -6.00243086326 -105.244558962 20.99399568 -6.01243086326 -105.244558962 20.99399568 -6.02243086326 -105.244558962 20.99399568 -6.03243086326 -105.244558962 20.99399568 -6.04243086326 -105.244558962 20.99399568 -6.05243086326 -105.244558962 20.99399568 -6.06243086326 -105.244558962 20.99399568 -6.07243086326 -105.244558962 20.99399568 -6.08243086326 -105.244558962 20.99399568 -6.09243086326 -105.244558962 20.99399568 -6.10243086326 -105.244558962 20.99399568 -6.11243086326 -105.244558962 20.99399568 -6.12243086326 -105.244558962 20.99399568 -6.13243086326 -105.244558962 20.99399568 -6.14243086326 -105.244558962 20.99399568 -6.15243086326 -105.244558962 20.99399568 -6.16243086326 -105.244558962 20.99399568 -6.17243086326 -105.244558962 20.99399568 -6.18243086326 -105.244558962 20.99399568 -6.19243086326 -105.244558962 20.99399568 -6.20243086326 288.09572754 20.99399568 -6.21243086326 712.732559929 20.99399568 -6.22243086326 772.985501405 20.99399568 -6.23243086326 808.407951245 20.99399568 -6.24243086326 914.125120204 20.99399568 -6.25243086326 1008.40284236 20.99399568 -6.26243086326 1045.86139076 20.99399568 -6.27243086326 1019.41538156 20.99399568 -6.28243086326 943.444647731 20.99399568 -6.29243086326 852.572766466 20.99399568 -6.30243086326 764.575035719 20.99399568 -6.31243086326 706.670419196 20.99399568 -6.32243086326 638.960403918 20.99399568 -6.33243086326 580.450352833 20.99399568 -6.34243086326 536.580845299 20.99399568 -6.35243086326 505.371399047 20.99399568 -6.36243086326 480.691546295 20.99399568 -6.37243086326 474.435937802 14.0814211676 -6.38243086326 472.279210555 15.3247570474 -6.39243086326 473.610399584 14.4580586116 -6.40243086326 486.850454345 15.620471506 -6.41243086326 512.66448365 15.6035325301 -6.42243086326 547.495979309 15.3062148961 -6.43243086326 582.106027845 14.9553372932 -6.44243086326 628.606825311 12.5611581671 -6.45243086326 666.715270261 8.91724410899 -6.46243086326 712.563514086 8.04971626724 -6.47243086326 762.125886884 8.04971626724 -6.48243086326 814.138794354 8.04971626724 -6.49243086326 854.878524639 8.04971626724 -6.50243086326 880.622222835 8.04971626724 -6.51243086326 893.904595518 8.04971626724 -6.52243086326 892.410907878 8.04971626724 -6.53243086326 876.827170167 8.04971626724 -6.54243086326 843.741460249 8.04971626724 -6.55243086326 795.965645593 8.04971626724 -6.56243086326 746.789989581 8.04971626724 -6.57243086326 725.333475851 8.04971626724 -6.58243086326 775.513674946 8.04971626724 -6.59243086326 685.346323082 8.04971626724 -6.60243086326 583.468034609 8.04971626724 -6.61243086326 518.895464831 8.04971626724 -6.62243086326 478.807274911 8.04971626724 -6.63243086326 438.158182534 8.04971626724 -6.64243086326 418.066849681 8.04971626724 -6.65243086326 410.248843 8.04971626724 -6.66243086326 413.796070005 8.04971626724 -6.67243086326 416.831605121 8.04971626724 -6.68243086326 430.366390637 8.04971626724 -6.69243086326 434.947648559 8.04971626724 -6.70243086326 437.28439179 8.04971626724 -6.71243086326 436.123946653 8.04971626724 -6.72243086326 425.165808959 8.04971626724 -6.73243086326 412.502494349 8.04971626724 -6.74243086326 401.780485414 8.04971626724 -6.75243086326 391.140100952 8.04971626724 -6.76243086326 379.558463507 8.04971626724 -6.77243086326 364.53689056 8.04971626724 -6.78243086326 348.834327663 8.04971626724 -6.79243086326 347.917856597 8.04971626724 -6.80243086326 351.171720119 8.04971626724 -6.81243086326 344.860986657 8.04971626724 -6.82243086326 337.50568327 8.04971626724 -6.83243086326 329.707777644 8.04971626724 -6.84243086326 322.144925089 8.04971626724 -6.85243086326 319.221930439 8.04971626724 -6.86243086326 316.111076651 8.04971626724 -6.87243086326 307.162890721 8.04971626724 -6.88243086326 295.308620262 8.04971626724 -6.89243086326 282.17438279 8.04971626724 -6.90243086326 284.038240617 8.04971626724 -6.91243086326 288.674912496 8.04971626724 -6.92243086326 273.048048083 8.04971626724 -6.93243086326 251.539314941 8.04971626724 -6.94243086326 250.979925716 8.04971626724 -6.95243086326 242.833761374 8.04971626724 -6.96243086326 236.407862849 8.04971626724 -6.97243086326 225.821622649 8.04971626724 -6.98243086326 217.43782282 8.04971626724 -6.99243086326 208.337875313 8.04971626724 -7.00243086326 203.068174095 8.04971626724 -7.01243086326 184.442735215 8.04971626724 -7.02243086326 169.6937911 8.04971626724 -7.03243086326 161.750901351 8.04971626724 -7.04243086326 152.501474302 8.04971626724 -7.05243086326 150.466765278 8.04971626724 -7.06243086326 141.804539292 8.04971626724 -7.07243086326 124.781167203 8.04971626724 -7.08243086326 110.927277744 8.04971626724 -7.09243086326 96.4546587455 8.04971626724 -7.10243086326 83.117235162 8.04971626724 -7.11243086326 64.9052661698 8.04971626724 -7.12243086326 28.840437144 8.04971626724 -7.13243086326 -10.104791269 8.04971626724 -7.14243086326 -44.7974525272 8.04971626724 -7.15243086326 -67.8089771516 8.04971626724 -7.16243086326 -88.1933348527 8.04971626724 -7.17243086326 -115.103518856 8.04971626724 -7.18243086326 -144.111969305 8.04971626724 -7.19243086326 -153.18920118 8.04971626724 -7.20243086326 -141.708379346 8.04971626724 -7.21243086326 -141.708379346 8.04971626724 -7.22243086326 -141.708379346 8.04971626724 -7.23243086326 -141.708379346 8.04971626724 -7.24243086326 -141.708379346 8.04971626724 -7.25243086326 -141.708379346 8.04971626724 -7.26243086326 -141.708379346 8.04971626724 -7.27243086326 -141.708379346 8.04971626724 -7.28243086326 -141.708379346 8.04971626724 -7.29243086326 -141.708379346 8.04971626724 -7.30243086326 -141.708379346 8.04971626724 -7.31243086326 -141.708379346 8.04971626724 -7.32243086326 -141.708379346 8.04971626724 -7.33243086326 -141.708379346 8.04971626724 -7.34243086326 -141.708379346 8.04971626724 -7.35243086326 -141.708379346 8.04971626724 -7.36243086326 -141.708379346 8.04971626724 -7.37243086326 -141.708379346 8.04971626724 -7.38243086326 -141.708379346 8.04971626724 -7.39243086326 -141.708379346 8.04971626724 -7.40243086326 -141.708379346 8.04971626724 -7.41243086326 -141.708379346 8.04971626724 -7.42243086326 -141.708379346 8.04971626724 -7.43243086326 -141.708379346 8.04971626724 -7.44243086326 -141.708379346 8.04971626724 -7.45243086326 -141.708379346 8.04971626724 -7.46243086326 -141.708379346 8.04971626724 -7.47243086326 -141.708379346 8.04971626724 -7.48243086326 -141.708379346 8.04971626724 -7.49243086326 -141.708379346 8.04971626724 -7.50243086326 -141.708379346 8.04971626724 -7.51243086326 -141.708379346 8.04971626724 -7.52243086326 -141.708379346 8.04971626724 -7.53243086326 -141.708379346 8.04971626724 -7.54243086326 -141.708379346 8.04971626724 -7.55243086326 -141.708379346 8.04971626724 -7.56243086326 -141.708379346 8.04971626724 -7.57243086326 -141.708379346 8.04971626724 -7.58243086326 -141.708379346 8.04971626724 -7.59243086326 -141.708379346 8.04971626724 -7.60243086326 -141.708379346 8.04971626724 -7.61243086326 -141.708379346 8.04971626724 -7.62243086326 -141.708379346 8.04971626724 -7.63243086326 -141.708379346 8.04971626724 -7.64243086326 -141.708379346 8.04971626724 -7.65243086326 -141.708379346 8.04971626724 -7.66243086326 -141.708379346 8.04971626724 -7.67243086326 -141.708379346 8.04971626724 -7.68243086326 -141.708379346 8.04971626724 -7.69243086326 -141.708379346 8.04971626724 -7.70243086326 -141.708379346 8.04971626724 -7.71243086326 -141.708379346 8.04971626724 -7.72243086326 -141.708379346 8.04971626724 -7.73243086326 -141.708379346 8.04971626724 -7.74243086326 -141.708379346 8.04971626724 -7.75243086326 -141.708379346 8.04971626724 -7.76243086326 -141.708379346 8.04971626724 -7.77243086326 -141.708379346 8.04971626724 -7.78243086326 -141.708379346 8.04971626724 -7.79243086326 -141.708379346 8.04971626724 -7.80243086326 -141.708379346 8.04971626724 -7.81243086326 -141.708379346 8.04971626724 -7.82243086326 -141.708379346 8.04971626724 -7.83243086326 -141.708379346 8.04971626724 -7.84243086326 -141.708379346 8.04971626724 -7.85243086326 -141.708379346 8.04971626724 -7.86243086326 -141.708379346 8.04971626724 -7.87243086326 -141.708379346 8.04971626724 -7.88243086326 -141.708379346 8.04971626724 -7.89243086326 -141.708379346 8.04971626724 -7.90243086326 -141.708379346 8.04971626724 -7.91243086326 -141.708379346 8.04971626724 -7.92243086326 -141.708379346 8.04971626724 -7.93243086326 -141.708379346 8.04971626724 -7.94243086326 -141.708379346 8.04971626724 -7.95243086326 -141.708379346 8.04971626724 -7.96243086326 -141.708379346 8.04971626724 -7.97243086326 -141.708379346 8.04971626724 -7.98243086326 -141.708379346 8.04971626724 -7.99243086326 -141.708379346 8.04971626724 -8.00243086326 -141.708379346 8.04971626724 -8.01243086326 -141.708379346 8.04971626724 -8.02243086326 -141.708379346 8.04971626724 -8.03243086326 -141.708379346 8.04971626724 -8.04243086326 -141.708379346 8.04971626724 -8.05243086326 -141.708379346 8.04971626724 -8.06243086326 -141.708379346 8.04971626724 -8.07243086326 -141.708379346 8.04971626724 -8.08243086326 -141.708379346 8.04971626724 -8.09243086326 -141.708379346 8.04971626724 -8.10243086326 -141.708379346 8.04971626724 -8.11243086326 97.6576667079 8.04971626724 -8.12243086326 163.688381046 8.04971626724 -8.13243086326 350.114830906 8.04971626724 -8.14243086326 483.857423431 8.04971626724 -8.15243086326 699.512030551 8.04971626724 -8.16243086326 863.687404285 8.04971626724 -8.17243086326 972.512735297 8.04971626724 -8.18243086326 1046.4077518 8.04971626724 -8.19243086326 994.052401304 8.04971626724 -8.20243086326 922.010100156 8.04971626724 -8.21243086326 927.474859535 8.04971626724 -8.22243086326 834.437232755 8.04971626724 -8.23243086326 732.263686179 8.04971626724 -8.24243086326 659.432983645 8.04971626724 -8.25243086326 591.960033312 8.04971626724 -8.26243086326 543.491058768 8.04971626724 -8.27243086326 502.526469334 8.04971626724 -8.28243086326 476.761062802 17.174225287 -8.29243086326 460.9815501 17.9218454655 -8.30243086326 457.838411497 15.743572735 -8.31243086326 467.760785082 16.5419854305 -8.32243086326 479.673836732 16.5299031116 -8.33243086326 501.441258913 16.9703152098 -8.34243086326 533.136176593 16.8823821861 -8.35243086326 565.91200553 15.2016669304 -8.36243086326 612.044888888 14.3575850836 -8.37243086326 643.545302003 13.6738015773 -8.38243086326 690.895282187 11.190249034 -8.39243086326 752.966159528 10.2653301279 -8.40243086326 795.914702608 10.2653301279 -8.41243086326 847.013280255 10.2653301279 -8.42243086326 887.587753728 10.2653301279 -8.43243086326 912.241766632 10.2653301279 -8.44243086326 931.668046427 10.2653301279 -8.45243086326 930.230894171 10.2653301279 -8.46243086326 908.280082278 10.2653301279 -8.47243086326 881.044295718 10.2653301279 -8.48243086326 842.01866193 10.2653301279 -8.49243086326 854.286820131 10.2653301279 -8.50243086326 817.220588267 10.2653301279 -8.51243086326 764.719455885 10.2653301279 -8.52243086326 694.559823663 10.2653301279 -8.53243086326 617.45192742 10.2653301279 -8.54243086326 559.873791078 10.2653301279 -8.55243086326 517.873193316 10.2653301279 -8.56243086326 471.583809994 10.2653301279 -8.57243086326 431.918595472 10.2653301279 -8.58243086326 403.855913064 10.2653301279 -8.59243086326 381.603452265 10.2653301279 -8.60243086326 354.835871697 10.2653301279 -8.61243086326 347.366174052 10.2653301279 -8.62243086326 346.000883652 10.2653301279 -8.63243086326 355.591409902 10.2653301279 -8.64243086326 369.017983004 10.2653301279 -8.65243086326 374.365159484 10.2653301279 -8.66243086326 381.239134907 10.2653301279 -8.67243086326 393.576644779 10.2653301279 -8.68243086326 378.385152199 10.2653301279 -8.69243086326 370.471734945 10.2653301279 -8.70243086326 363.666542789 10.2653301279 -8.71243086326 343.58995709 10.2653301279 -8.72243086326 342.016074466 10.2653301279 -8.73243086326 348.89337973 10.2653301279 -8.74243086326 361.664149931 10.2653301279 -8.75243086326 363.568494786 10.2653301279 -8.76243086326 345.514092296 10.2653301279 -8.77243086326 333.07083497 10.2653301279 -8.78243086326 321.991765989 10.2653301279 -8.79243086326 308.885917114 10.2653301279 -8.80243086326 280.76990916 10.2653301279 -8.81243086326 272.855055559 10.2653301279 -8.82243086326 270.644804736 10.2653301279 -8.83243086326 274.278250183 10.2653301279 -8.84243086326 270.628732249 10.2653301279 -8.85243086326 266.230190893 10.2653301279 -8.86243086326 258.561954077 10.2653301279 -8.87243086326 248.555391664 10.2653301279 -8.88243086326 230.253212134 10.2653301279 -8.89243086326 209.948270397 10.2653301279 -8.90243086326 197.740659472 10.2653301279 -8.91243086326 162.721405216 10.2653301279 -8.92243086326 142.296430042 10.2653301279 -8.93243086326 110.48139378 10.2653301279 -8.94243086326 82.0564390356 10.2653301279 -8.95243086326 55.2439666409 10.2653301279 -8.96243086326 47.7823674658 10.2653301279 -8.97243086326 33.7195753162 10.2653301279 -8.98243086326 29.90569297 10.2653301279 -8.99243086326 30.3934888925 10.2653301279 -9.00243086326 33.8497714533 10.2653301279 -9.01243086326 38.1933003453 10.2653301279 -9.02243086326 13.5287188838 10.2653301279 -9.03243086326 -9.28719389097 10.2653301279 -9.04243086326 -34.9643986101 10.2653301279 -9.05243086326 -63.1706523156 10.2653301279 -9.06243086326 -98.226954714 10.2653301279 -9.07243086326 -81.5179160562 10.2653301279 -9.08243086326 -86.6048268813 10.2653301279 -9.09243086326 -97.7271405334 10.2653301279 -9.10243086326 -111.235228069 10.2653301279 -9.11243086326 -110.093104204 10.2653301279 -9.12243086326 -116.280705817 10.2653301279 -9.13243086326 -96.405426991 10.2653301279 -9.14243086326 -93.0229861856 10.2653301279 -9.15243086326 -72.8769001351 10.2653301279 -9.16243086326 -54.6114339956 10.2653301279 -9.17243086326 -32.2965498339 10.2653301279 -9.18243086326 -16.1361109385 10.2653301279 -9.19243086326 -10.4062604656 10.2653301279 -9.20243086326 -10.4062604656 10.2653301279 -9.21243086326 -10.4062604656 10.2653301279 -9.22243086326 -10.4062604656 10.2653301279 -9.23243086326 -10.4062604656 10.2653301279 -9.24243086326 -10.4062604656 10.2653301279 -9.25243086326 -10.4062604656 10.2653301279 -9.26243086326 -10.4062604656 10.2653301279 -9.27243086326 -10.4062604656 10.2653301279 -9.28243086326 -10.4062604656 10.2653301279 -9.29243086326 -10.4062604656 10.2653301279 -9.30243086326 -10.4062604656 10.2653301279 -9.31243086326 -10.4062604656 10.2653301279 -9.32243086326 -10.4062604656 10.2653301279 -9.33243086326 -10.4062604656 10.2653301279 -9.34243086326 -10.4062604656 10.2653301279 -9.35243086326 -10.4062604656 10.2653301279 -9.36243086326 -10.4062604656 10.2653301279 -9.37243086326 -10.4062604656 10.2653301279 -9.38243086326 -10.4062604656 10.2653301279 -9.39243086326 -10.4062604656 10.2653301279 -9.40243086326 -10.4062604656 10.2653301279 -9.41243086326 -10.4062604656 10.2653301279 -9.42243086326 -10.4062604656 10.2653301279 -9.43243086326 -10.4062604656 10.2653301279 -9.44243086326 -10.4062604656 10.2653301279 -9.45243086326 -10.4062604656 10.2653301279 -9.46243086326 -10.4062604656 10.2653301279 -9.47243086326 -10.4062604656 10.2653301279 -9.48243086326 -10.4062604656 10.2653301279 -9.49243086326 -10.4062604656 10.2653301279 -9.50243086326 -10.4062604656 10.2653301279 -9.51243086326 -10.4062604656 10.2653301279 -9.52243086326 -10.4062604656 10.2653301279 -9.53243086326 -10.4062604656 10.2653301279 -9.54243086326 -10.4062604656 10.2653301279 -9.55243086326 -10.4062604656 10.2653301279 -9.56243086326 -10.4062604656 10.2653301279 -9.57243086326 -10.4062604656 10.2653301279 -9.58243086326 -10.4062604656 10.2653301279 -9.59243086326 -10.4062604656 10.2653301279 -9.60243086326 -10.4062604656 10.2653301279 -9.61243086326 -10.4062604656 10.2653301279 -9.62243086326 -10.4062604656 10.2653301279 -9.63243086326 -10.4062604656 10.2653301279 -9.64243086326 -10.4062604656 10.2653301279 -9.65243086326 -10.4062604656 10.2653301279 -9.66243086326 -10.4062604656 10.2653301279 -9.67243086326 -10.4062604656 10.2653301279 -9.68243086326 -10.4062604656 10.2653301279 -9.69243086326 -10.4062604656 10.2653301279 -9.70243086326 -10.4062604656 10.2653301279 -9.71243086326 -10.4062604656 10.2653301279 -9.72243086326 -10.4062604656 10.2653301279 -9.73243086326 -10.4062604656 10.2653301279 -9.74243086326 -10.4062604656 10.2653301279 -9.75243086326 -10.4062604656 10.2653301279 -9.76243086326 -10.4062604656 10.2653301279 -9.77243086326 -10.4062604656 10.2653301279 -9.78243086326 -10.4062604656 10.2653301279 -9.79243086326 -10.4062604656 10.2653301279 -9.80243086326 -10.4062604656 10.2653301279 -9.81243086326 -10.4062604656 10.2653301279 -9.82243086326 -10.4062604656 10.2653301279 -9.83243086326 -10.4062604656 10.2653301279 -9.84243086326 -10.4062604656 10.2653301279 -9.85243086326 -10.4062604656 10.2653301279 -9.86243086326 -10.4062604656 10.2653301279 -9.87243086326 -10.4062604656 10.2653301279 -9.88243086326 -10.4062604656 10.2653301279 -9.89243086326 -10.4062604656 10.2653301279 -9.90243086326 -10.4062604656 10.2653301279 -9.91243086326 -10.4062604656 10.2653301279 -9.92243086326 -10.4062604656 10.2653301279 -9.93243086326 -10.4062604656 10.2653301279 -9.94243086326 -10.4062604656 10.2653301279 -9.95243086326 -10.4062604656 10.2653301279 -9.96243086326 -10.4062604656 10.2653301279 -9.97243086326 -10.4062604656 10.2653301279 -9.98243086326 -10.4062604656 10.2653301279 -9.99243086326 -10.4062604656 10.2653301279 -10.0024308633 -10.4062604656 10.2653301279 -10.0124308633 161.381813473 10.2653301279 -10.0224308633 330.936972738 10.2653301279 -10.0324308633 879.052621765 10.2653301279 -10.0424308633 1039.24985861 10.2653301279 -10.0524308633 1138.09691226 10.2653301279 -10.0624308633 1196.74686366 10.2653301279 -10.0724308633 1158.77494366 10.2653301279 -10.0824308633 1010.6782199 10.2653301279 -10.0924308633 879.074665224 10.2653301279 -10.1024308633 732.42847566 10.2653301279 -10.1124308633 629.603873401 10.2653301279 -10.1224308633 545.852447471 10.2653301279 -10.1324308633 475.983094779 10.2653301279 -10.1424308633 429.250342993 10.2653301279 -10.1524308633 412.383582076 10.2653301279 -10.1624308633 417.468269137 10.2653301279 -10.1724308633 419.415587506 10.2653301279 -10.1824308633 429.670748882 10.2653301279 -10.1924308633 451.320882139 10.2653301279 -10.2024308633 474.910541506 10.2653301279 -10.2124308633 501.462229169 10.2653301279 -10.2224308633 535.565130273 10.2653301279 -10.2324308633 574.265486964 10.2653301279 -10.2424308633 622.178601261 10.2653301279 -10.2524308633 664.900883208 10.2653301279 -10.2624308633 709.870787518 10.2653301279 -10.2724308633 763.072944533 10.2653301279 -10.2824308633 786.671964539 10.2653301279 -10.2924308633 807.999556751 10.2653301279 -10.3024308633 824.32620327 10.2653301279 -10.3124308633 830.655632093 10.2653301279 -10.3224308633 822.750596541 10.2653301279 -10.3324308633 798.118785627 10.2653301279 -10.3424308633 781.387212082 10.2653301279 -10.3524308633 759.408239622 10.2653301279 -10.3624308633 723.404500838 10.2653301279 -10.3724308633 698.849596674 10.2653301279 -10.3824308633 613.660306406 10.2653301279 -10.3924308633 573.37126504 10.2653301279 -10.4024308633 562.458356628 10.2653301279 -10.4124308633 545.467167722 10.2653301279 -10.4224308633 530.546377115 10.2653301279 -10.4324308633 507.521307718 10.2653301279 -10.4424308633 476.769015863 10.2653301279 -10.4524308633 439.540377103 10.2653301279 -10.4624308633 407.433320538 10.2653301279 -10.4724308633 376.954246284 10.2653301279 -10.4824308633 361.694387549 10.2653301279 -10.4924308633 353.093775448 10.2653301279 -10.5024308633 348.860848231 10.2653301279 -10.5124308633 344.72964397 10.2653301279 -10.5224308633 334.242868217 10.2653301279 -10.5324308633 321.963156807 10.2653301279 -10.5424308633 314.85299192 10.2653301279 -10.5524308633 310.913043523 10.2653301279 -10.5624308633 308.958714902 10.2653301279 -10.5724308633 308.614727637 10.2653301279 -10.5824308633 308.325552959 10.2653301279 -10.5924308633 307.747693717 10.2653301279 -10.6024308633 307.441082399 10.2653301279 -10.6124308633 305.391841039 10.2653301279 -10.6224308633 308.433918441 10.2653301279 -10.6324308633 300.872761338 10.2653301279 -10.6424308633 304.579596013 10.2653301279 -10.6524308633 302.748269615 10.2653301279 -10.6624308633 296.291310312 10.2653301279 -10.6724308633 289.217856453 10.2653301279 -10.6824308633 290.308100643 10.2653301279 -10.6924308633 281.839955353 10.2653301279 -10.7024308633 278.415316406 10.2653301279 -10.7124308633 268.718814165 10.2653301279 -10.7224308633 270.638658463 10.2653301279 -10.7324308633 263.621416073 10.2653301279 -10.7424308633 255.171916891 10.2653301279 -10.7524308633 243.280045027 10.2653301279 -10.7624308633 238.622392846 10.2653301279 -10.7724308633 234.598105371 10.2653301279 -10.7824308633 230.969768518 10.2653301279 -10.7924308633 218.830133008 10.2653301279 -10.8024308633 210.212848041 10.2653301279 -10.8124308633 199.153774621 10.2653301279 -10.8224308633 187.448006622 10.2653301279 -10.8324308633 178.46921108 10.2653301279 -10.8424308633 165.666079398 10.2653301279 -10.8524308633 154.257054615 10.2653301279 -10.8624308633 144.736234406 10.2653301279 -10.8724308633 138.656757535 10.2653301279 -10.8824308633 129.493175993 10.2653301279 -10.8924308633 113.420473676 10.2653301279 -10.9024308633 95.6140038829 10.2653301279 -10.9124308633 79.8606679856 10.2653301279 -10.9224308633 64.9869607363 10.2653301279 -10.9324308633 52.5687993883 10.2653301279 -10.9424308633 28.084045514 10.2653301279 -10.9524308633 10.7809952041 10.2653301279 -10.9624308633 -8.86115408433 10.2653301279 -10.9724308633 -24.8961738545 10.2653301279 -10.9824308633 -45.8842987506 10.2653301279 -10.9924308633 -65.1258736108 10.2653301279 -11.0024308633 -79.5505352521 10.2653301279 -11.0124308633 -90.6902952877 10.2653301279 -11.0224308633 -98.2677474515 10.2653301279 -11.0324308633 -102.609102408 10.2653301279 -11.0424308633 -102.609102408 10.2653301279 -11.0524308633 -102.609102408 10.2653301279 -11.0624308633 -102.609102408 10.2653301279 -11.0724308633 -102.609102408 10.2653301279 -11.0824308633 -102.609102408 10.2653301279 -11.0924308633 -102.609102408 10.2653301279 -11.1024308633 -102.609102408 10.2653301279 -11.1124308633 -102.609102408 10.2653301279 -11.1224308633 -102.609102408 10.2653301279 -11.1324308633 -102.609102408 10.2653301279 -11.1424308633 -102.609102408 10.2653301279 -11.1524308633 -102.609102408 10.2653301279 -11.1624308633 -102.609102408 10.2653301279 -11.1724308633 -102.609102408 10.2653301279 -11.1824308633 -102.609102408 10.2653301279 -11.1924308633 -102.609102408 10.2653301279 -11.2024308633 -102.609102408 10.2653301279 -11.2124308633 -102.609102408 10.2653301279 -11.2224308633 -102.609102408 10.2653301279 -11.2324308633 -102.609102408 10.2653301279 -11.2424308633 -102.609102408 10.2653301279 -11.2524308633 -102.609102408 10.2653301279 -11.2624308633 -102.609102408 10.2653301279 -11.2724308633 -102.609102408 10.2653301279 -11.2824308633 -102.609102408 10.2653301279 -11.2924308633 -102.609102408 10.2653301279 -11.3024308633 -102.609102408 10.2653301279 -11.3124308633 -102.609102408 10.2653301279 -11.3224308633 -102.609102408 10.2653301279 -11.3324308633 -102.609102408 10.2653301279 -11.3424308633 -102.609102408 10.2653301279 -11.3524308633 -102.609102408 10.2653301279 -11.3624308633 -102.609102408 10.2653301279 -11.3724308633 -102.609102408 10.2653301279 -11.3824308633 -102.609102408 10.2653301279 -11.3924308633 -102.609102408 10.2653301279 -11.4024308633 -102.609102408 10.2653301279 -11.4124308633 -102.609102408 10.2653301279 -11.4224308633 -102.609102408 10.2653301279 -11.4324308633 -102.609102408 10.2653301279 -11.4424308633 -102.609102408 10.2653301279 -11.4524308633 -102.609102408 10.2653301279 -11.4624308633 -102.609102408 10.2653301279 -11.4724308633 -102.609102408 10.2653301279 -11.4824308633 -102.609102408 10.2653301279 -11.4924308633 -102.609102408 10.2653301279 -11.5024308633 -102.609102408 10.2653301279 -11.5124308633 -102.609102408 10.2653301279 -11.5224308633 -102.609102408 10.2653301279 -11.5324308633 -102.609102408 10.2653301279 -11.5424308633 -102.609102408 10.2653301279 -11.5524308633 -102.609102408 10.2653301279 -11.5624308633 -102.609102408 10.2653301279 -11.5724308633 -102.609102408 10.2653301279 -11.5824308633 -102.609102408 10.2653301279 -11.5924308633 -102.609102408 10.2653301279 -11.6024308633 -102.609102408 10.2653301279 -11.6124308633 -102.609102408 10.2653301279 -11.6224308633 -102.609102408 10.2653301279 -11.6324308633 -102.609102408 10.2653301279 -11.6424308633 -102.609102408 10.2653301279 -11.6524308633 -102.609102408 10.2653301279 -11.6624308633 -102.609102408 10.2653301279 -11.6724308633 -102.609102408 10.2653301279 -11.6824308633 -102.609102408 10.2653301279 -11.6924308633 -102.609102408 10.2653301279 -11.7024308633 -102.609102408 10.2653301279 -11.7124308633 -102.609102408 10.2653301279 -11.7224308633 -102.609102408 10.2653301279 -11.7324308633 -102.609102408 10.2653301279 -11.7424308633 -102.609102408 10.2653301279 -11.7524308633 -102.609102408 10.2653301279 -11.7624308633 -102.609102408 10.2653301279 -11.7724308633 -102.609102408 10.2653301279 -11.7824308633 -102.609102408 10.2653301279 -11.7924308633 -102.609102408 10.2653301279 -11.8024308633 -102.609102408 10.2653301279 -11.8124308633 -102.609102408 10.2653301279 -11.8224308633 -102.609102408 10.2653301279 -11.8324308633 -102.609102408 10.2653301279 -11.8424308633 -102.609102408 10.2653301279 -11.8524308633 -102.609102408 10.2653301279 -11.8624308633 -102.609102408 10.2653301279 -11.8724308633 -102.609102408 10.2653301279 -11.8824308633 -102.609102408 10.2653301279 -11.8924308633 -102.609102408 10.2653301279 -11.9024308633 -102.609102408 10.2653301279 -11.9124308633 -102.609102408 10.2653301279 -11.9224308633 -102.609102408 10.2653301279 -11.9324308633 -102.609102408 10.2653301279 -11.9424308633 125.56680696 10.2653301279 -11.9524308633 233.652880034 10.2653301279 -11.9624308633 382.82340307 10.2653301279 -11.9724308633 618.38410995 10.2653301279 -11.9824308633 832.333207764 10.2653301279 -11.9924308633 1017.51822176 10.2653301279 -12.0024308633 1178.39266423 10.2653301279 -12.0124308633 1214.12554305 10.2653301279 -12.0224308633 1125.06304038 10.2653301279 -12.0324308633 1061.78814644 10.2653301279 -12.0424308633 932.544553493 10.2653301279 -12.0524308633 791.989382924 10.2653301279 -12.0624308633 649.298979791 10.2653301279 -12.0724308633 558.631361702 10.2653301279 -12.0824308633 489.923888784 10.2653301279 -12.0924308633 453.612077248 10.2653301279 -12.1024308633 422.053033318 10.2653301279 -12.1124308633 385.218498957 10.2653301279 -12.1224308633 377.561382508 10.2653301279 -12.1324308633 394.551768052 -11.1582601775 -12.1424308633 401.110338859 -13.3559982041 -12.1524308633 429.502630251 -13.3559982041 -12.1624308633 477.275979807 -13.3559982041 -12.1724308633 526.042498667 -13.3559982041 -12.1824308633 581.654536827 -13.3559982041 -12.1924308633 636.846808147 -13.3559982041 -12.2024308633 694.863726461 -13.3559982041 -12.2124308633 724.136653021 -13.3559982041 -12.2224308633 752.321730523 -13.3559982041 -12.2324308633 771.849818683 -13.3559982041 -12.2424308633 785.195419575 -13.3559982041 -12.2524308633 778.037583426 -13.3559982041 -12.2624308633 767.516696105 -13.3559982041 -12.2724308633 794.565736667 -13.3559982041 -12.2824308633 838.457925557 -13.3559982041 -12.2924308633 853.767754773 -13.3559982041 -12.3024308633 791.349399945 -13.3559982041 -12.3124308633 790.625662618 -13.3559982041 -12.3224308633 722.721635322 -13.3559982041 -12.3324308633 672.175426306 -13.3559982041 -12.3424308633 627.637300615 -13.3559982041 -12.3524308633 591.857843814 -13.3559982041 -12.3624308633 571.826360823 -13.3559982041 -12.3724308633 555.412937185 -13.3559982041 -12.3824308633 535.332687178 -13.3559982041 -12.3924308633 489.917551099 -13.3559982041 -12.4024308633 446.463935083 -13.3559982041 -12.4124308633 399.105929755 -13.3559982041 -12.4224308633 366.925126308 -13.3559982041 -12.4324308633 367.20831108 -13.3559982041 -12.4424308633 354.903990952 -13.3559982041 -12.4524308633 347.548032899 -13.3559982041 -12.4624308633 352.211177659 -13.3559982041 -12.4724308633 338.86816399 -13.3559982041 -12.4824308633 355.075986164 -13.3559982041 -12.4924308633 371.104882146 -13.3559982041 -12.5024308633 386.028320097 -13.3559982041 -12.5124308633 395.219488596 -13.3559982041 -12.5224308633 393.863067281 -13.3559982041 -12.5324308633 394.508986694 -13.3559982041 -12.5424308633 378.805686402 -13.3559982041 -12.5524308633 362.385578884 -13.3559982041 -12.5624308633 374.318500814 -13.3559982041 -12.5724308633 355.42225474 -13.3559982041 -12.5824308633 351.361864184 -13.3559982041 -12.5924308633 337.627659365 -13.3559982041 -12.6024308633 325.180845504 -13.3559982041 -12.6124308633 315.73767822 -13.3559982041 -12.6224308633 295.679350285 -13.3559982041 -12.6324308633 285.409168299 -13.3559982041 -12.6424308633 274.5039271 -13.3559982041 -12.6524308633 264.625101135 -13.3559982041 -12.6624308633 259.291362864 -13.3559982041 -12.6724308633 245.884858668 -13.3559982041 -12.6824308633 233.371920225 -13.3559982041 -12.6924308633 210.053015594 -13.3559982041 -12.7024308633 198.371521353 -13.3559982041 -12.7124308633 184.856188981 -13.3559982041 -12.7224308633 178.270880573 -13.3559982041 -12.7324308633 163.910344053 -13.3559982041 -12.7424308633 161.018959435 -13.3559982041 -12.7524308633 148.352856654 -13.3559982041 -12.7624308633 127.675508668 -13.3559982041 -12.7724308633 102.946810457 -13.3559982041 -12.7824308633 88.7166880162 -13.3559982041 -12.7924308633 81.8758908847 -13.3559982041 -12.8024308633 92.9430522248 -13.3559982041 -12.8124308633 90.4771297871 -13.3559982041 -12.8224308633 81.4728179382 -13.3559982041 -12.8324308633 68.0023940675 -13.3559982041 -12.8424308633 49.7200019545 -13.3559982041 -12.8524308633 30.1585413903 -13.3559982041 -12.8624308633 2.53720631139 -13.3559982041 -12.8724308633 -16.7843152287 -13.3559982041 -12.8824308633 -23.0546195256 -13.3559982041 -12.8924308633 -42.8433668505 -13.3559982041 -12.9024308633 -67.8672728609 -13.3559982041 -12.9124308633 -86.8225012127 -13.3559982041 -12.9224308633 -84.222101319 -13.3559982041 -12.9324308633 -101.367691136 -13.3559982041 -12.9424308633 -117.719889375 -13.3559982041 -12.9524308633 -117.719889375 -13.3559982041 -12.9624308633 -117.719889375 -13.3559982041 -12.9724308633 -117.719889375 -13.3559982041 -12.9824308633 -117.719889375 -13.3559982041 -12.9924308633 -117.719889375 -13.3559982041 -13.0024308633 -117.719889375 -13.3559982041 -13.0124308633 -117.719889375 -13.3559982041 -13.0224308633 -117.719889375 -13.3559982041 -13.0324308633 -117.719889375 -13.3559982041 -13.0424308633 -117.719889375 -13.3559982041 -13.0524308633 -117.719889375 -13.3559982041 -13.0624308633 -117.719889375 -13.3559982041 -13.0724308633 -117.719889375 -13.3559982041 -13.0824308633 -117.719889375 -13.3559982041 -13.0924308633 -117.719889375 -13.3559982041 -13.1024308633 -117.719889375 -13.3559982041 -13.1124308633 -117.719889375 -13.3559982041 -13.1224308633 -117.719889375 -13.3559982041 -13.1324308633 -117.719889375 -13.3559982041 -13.1424308633 -117.719889375 -13.3559982041 -13.1524308633 -117.719889375 -13.3559982041 -13.1624308633 -117.719889375 -13.3559982041 -13.1724308633 -117.719889375 -13.3559982041 -13.1824308633 -117.719889375 -13.3559982041 -13.1924308633 -117.719889375 -13.3559982041 -13.2024308633 -117.719889375 -13.3559982041 -13.2124308633 -117.719889375 -13.3559982041 -13.2224308633 -117.719889375 -13.3559982041 -13.2324308633 -117.719889375 -13.3559982041 -13.2424308633 -117.719889375 -13.3559982041 -13.2524308633 -117.719889375 -13.3559982041 -13.2624308633 -117.719889375 -13.3559982041 -13.2724308633 -117.719889375 -13.3559982041 -13.2824308633 -117.719889375 -13.3559982041 -13.2924308633 -117.719889375 -13.3559982041 -13.3024308633 -117.719889375 -13.3559982041 -13.3124308633 -117.719889375 -13.3559982041 -13.3224308633 -117.719889375 -13.3559982041 -13.3324308633 -117.719889375 -13.3559982041 -13.3424308633 -117.719889375 -13.3559982041 -13.3524308633 -117.719889375 -13.3559982041 -13.3624308633 -117.719889375 -13.3559982041 -13.3724308633 -117.719889375 -13.3559982041 -13.3824308633 -117.719889375 -13.3559982041 -13.3924308633 -117.719889375 -13.3559982041 -13.4024308633 -117.719889375 -13.3559982041 -13.4124308633 -117.719889375 -13.3559982041 -13.4224308633 -117.719889375 -13.3559982041 -13.4324308633 -117.719889375 -13.3559982041 -13.4424308633 -117.719889375 -13.3559982041 -13.4524308633 -117.719889375 -13.3559982041 -13.4624308633 -117.719889375 -13.3559982041 -13.4724308633 -117.719889375 -13.3559982041 -13.4824308633 -117.719889375 -13.3559982041 -13.4924308633 -117.719889375 -13.3559982041 -13.5024308633 -117.719889375 -13.3559982041 -13.5124308633 -117.719889375 -13.3559982041 -13.5224308633 -117.719889375 -13.3559982041 -13.5324308633 -117.719889375 -13.3559982041 -13.5424308633 -117.719889375 -13.3559982041 -13.5524308633 -117.719889375 -13.3559982041 -13.5624308633 -117.719889375 -13.3559982041 -13.5724308633 -117.719889375 -13.3559982041 -13.5824308633 -117.719889375 -13.3559982041 -13.5924308633 -117.719889375 -13.3559982041 -13.6024308633 -117.719889375 -13.3559982041 -13.6124308633 -117.719889375 -13.3559982041 -13.6224308633 -117.719889375 -13.3559982041 -13.6324308633 -117.719889375 -13.3559982041 -13.6424308633 -117.719889375 -13.3559982041 -13.6524308633 -117.719889375 -13.3559982041 -13.6624308633 -117.719889375 -13.3559982041 -13.6724308633 -117.719889375 -13.3559982041 -13.6824308633 -117.719889375 -13.3559982041 -13.6924308633 -117.719889375 -13.3559982041 -13.7024308633 -117.719889375 -13.3559982041 -13.7124308633 -117.719889375 -13.3559982041 -13.7224308633 -117.719889375 -13.3559982041 -13.7324308633 -117.719889375 -13.3559982041 -13.7424308633 -117.719889375 -13.3559982041 -13.7524308633 -117.719889375 -13.3559982041 -13.7624308633 -117.719889375 -13.3559982041 -13.7724308633 -117.719889375 -13.3559982041 -13.7824308633 -117.719889375 -13.3559982041 -13.7924308633 -117.719889375 -13.3559982041 -13.8024308633 -117.719889375 -13.3559982041 -13.8124308633 -117.719889375 -13.3559982041 -13.8224308633 -117.719889375 -13.3559982041 -13.8324308633 -31.6765126368 -13.3559982041 -13.8424308633 -90.8608818171 -13.3559982041 -13.8524308633 384.95104769 -13.3559982041 -13.8624308633 573.937117437 -13.3559982041 -13.8724308633 844.424361262 -13.3559982041 -13.8824308633 981.281091464 -13.3559982041 -13.8924308633 1131.291293 -13.3559982041 -13.9024308633 1161.38124684 -13.3559982041 -13.9124308633 1123.17471884 -13.3559982041 -13.9224308633 1056.41314302 -13.3559982041 -13.9324308633 958.904166107 -13.3559982041 -13.9424308633 822.134463674 -13.3559982041 -13.9524308633 725.135714216 -13.3559982041 -13.9624308633 636.251647298 10.9693643247 -13.9724308633 548.115586262 11.1408627114 -13.9824308633 486.411191446 10.7444332115 -13.9924308633 443.658060685 10.7444332115 -14.0024308633 422.821369097 10.7444332115 -14.0124308633 409.027765652 10.7444332115 -14.0224308633 411.202491742 10.7444332115 -14.0324308633 418.420359894 10.7444332115 -14.0424308633 436.940243727 10.7444332115 -14.0524308633 474.881576357 10.7444332115 -14.0624308633 508.571832479 10.7444332115 -14.0724308633 555.933119884 10.7444332115 -14.0824308633 619.419691801 10.7444332115 -14.0924308633 678.925965406 10.7444332115 -14.1024308633 740.840877327 10.7444332115 -14.1124308633 790.497250475 10.7444332115 -14.1224308633 830.239340243 10.7444332115 -14.1324308633 871.229505497 10.7444332115 -14.1424308633 887.153758977 10.7444332115 -14.1524308633 886.902475881 10.7444332115 -14.1624308633 872.862105758 10.7444332115 -14.1724308633 859.785162167 10.7444332115 -14.1824308633 824.423709584 10.7444332115 -14.1924308633 784.258849219 10.7444332115 -14.2024308633 738.128066339 10.7444332115 -14.2124308633 667.688264735 -0.611915589598 -14.2224308633 604.822615248 -1.31762303954 -14.2324308633 542.450651308 -2.14575437828 -14.2424308633 513.341601073 -2.14575437828 -14.2524308633 472.653257306 -2.14575437828 -14.2624308633 449.639547388 -2.14575437828 -14.2724308633 422.245901002 -2.14575437828 -14.2824308633 387.736000208 -2.14575437828 -14.2924308633 359.078004097 -2.14575437828 -14.3024308633 352.681492179 -2.14575437828 -14.3124308633 583.766942114 -2.14575437828 -14.3224308633 476.953841422 -2.14575437828 -14.3324308633 382.452705303 -2.14575437828 -14.3424308633 377.679578759 -2.14575437828 -14.3524308633 367.642378949 -2.14575437828 -14.3624308633 369.839584574 -2.14575437828 -14.3724308633 319.982100841 -2.14575437828 -14.3824308633 282.705137494 -2.14575437828 -14.3924308633 290.195153107 -2.14575437828 -14.4024308633 318.34073129 -2.14575437828 -14.4124308633 321.33020548 -2.14575437828 -14.4224308633 319.220656373 -2.14575437828 -14.4324308633 324.88425118 -2.14575437828 -14.4424308633 323.578430852 -2.14575437828 -14.4524308633 331.151560399 -2.14575437828 -14.4624308633 331.573261354 -2.14575437828 -14.4724308633 335.649593799 -2.14575437828 -14.4824308633 345.257773293 -2.14575437828 -14.4924308633 342.382756944 -2.14575437828 -14.5024308633 340.771531177 -2.14575437828 -14.5124308633 333.376103841 -2.14575437828 -14.5224308633 332.38970079 -2.14575437828 -14.5324308633 327.959046005 -2.14575437828 -14.5424308633 320.725497697 -2.14575437828 -14.5524308633 313.561749318 -2.14575437828 -14.5624308633 292.133765776 -2.14575437828 -14.5724308633 274.68682558 -2.14575437828 -14.5824308633 258.213259648 -2.14575437828 -14.5924308633 245.443961393 -2.14575437828 -14.6024308633 240.090429803 -2.14575437828 -14.6124308633 234.726643123 -2.14575437828 -14.6224308633 228.340205304 -2.14575437828 -14.6324308633 221.117527604 -2.14575437828 -14.6424308633 201.38334383 -2.14575437828 -14.6524308633 157.803537468 -2.14575437828 -14.6624308633 127.226947884 -2.14575437828 -14.6724308633 102.93517278 -2.14575437828 -14.6824308633 82.2012898822 -2.14575437828 -14.6924308633 66.5054489932 -2.14575437828 -14.7024308633 60.7336608933 -2.14575437828 -14.7124308633 41.6545970081 -2.14575437828 -14.7224308633 33.8451604287 -2.14575437828 -14.7324308633 34.0226782583 -2.14575437828 -14.7424308633 27.9548845773 -2.14575437828 -14.7524308633 20.2450814601 -2.14575437828 -14.7624308633 6.0297786604 -2.14575437828 -14.7724308633 12.16417922 -2.14575437828 -14.7824308633 5.09004105271 -2.14575437828 -14.7924308633 -8.53675415787 -2.14575437828 -14.8024308633 2.48554742072 -2.14575437828 -14.8124308633 14.3562762634 -2.14575437828 -14.8224308633 14.5741992971 -2.14575437828 -14.8324308633 9.37560546578 -2.14575437828 -14.8424308633 -2.00159285093 -2.14575437828 -14.8524308633 -54.6292429856 -2.14575437828 -14.8624308633 -39.5248874793 -2.14575437828 -14.8724308633 -69.4418398404 -2.14575437828 -14.8824308633 -93.4653958478 -2.14575437828 -14.8924308633 -81.8420033293 -2.14575437828 -14.9024308633 -94.4264549973 -2.14575437828 -14.9124308633 -107.261202231 -2.14575437828 -14.9224308633 -117.706734271 -2.14575437828 -14.9324308633 -117.706734271 -2.14575437828 -14.9424308633 -117.706734271 -2.14575437828 -14.9524308633 -117.706734271 -2.14575437828 -14.9624308633 -117.706734271 -2.14575437828 -14.9724308633 -117.706734271 -2.14575437828 -14.9824308633 -117.706734271 -2.14575437828 -14.9924308633 -117.706734271 -2.14575437828 -15.0024308633 -117.706734271 -2.14575437828 -15.0124308633 -117.706734271 -2.14575437828 -15.0224308633 -117.706734271 -2.14575437828 -15.0324308633 -117.706734271 -2.14575437828 -15.0424308633 -117.706734271 -2.14575437828 -15.0524308633 -117.706734271 -2.14575437828 -15.0624308633 -117.706734271 -2.14575437828 -15.0724308633 -117.706734271 -2.14575437828 -15.0824308633 -117.706734271 -2.14575437828 -15.0924308633 -117.706734271 -2.14575437828 -15.1024308633 -117.706734271 -2.14575437828 -15.1124308633 -117.706734271 -2.14575437828 -15.1224308633 -117.706734271 -2.14575437828 -15.1324308633 -117.706734271 -2.14575437828 -15.1424308633 -117.706734271 -2.14575437828 -15.1524308633 -117.706734271 -2.14575437828 -15.1624308633 -117.706734271 -2.14575437828 -15.1724308633 -117.706734271 -2.14575437828 -15.1824308633 -117.706734271 -2.14575437828 -15.1924308633 -117.706734271 -2.14575437828 -15.2024308633 -117.706734271 -2.14575437828 -15.2124308633 -117.706734271 -2.14575437828 -15.2224308633 -117.706734271 -2.14575437828 -15.2324308633 -117.706734271 -2.14575437828 -15.2424308633 -117.706734271 -2.14575437828 -15.2524308633 -117.706734271 -2.14575437828 -15.2624308633 -117.706734271 -2.14575437828 -15.2724308633 -117.706734271 -2.14575437828 -15.2824308633 -117.706734271 -2.14575437828 -15.2924308633 -117.706734271 -2.14575437828 -15.3024308633 -117.706734271 -2.14575437828 -15.3124308633 -117.706734271 -2.14575437828 -15.3224308633 -117.706734271 -2.14575437828 -15.3324308633 -117.706734271 -2.14575437828 -15.3424308633 -117.706734271 -2.14575437828 -15.3524308633 -117.706734271 -2.14575437828 -15.3624308633 -117.706734271 -2.14575437828 -15.3724308633 -117.706734271 -2.14575437828 -15.3824308633 -117.706734271 -2.14575437828 -15.3924308633 -117.706734271 -2.14575437828 -15.4024308633 -117.706734271 -2.14575437828 -15.4124308633 -117.706734271 -2.14575437828 -15.4224308633 -117.706734271 -2.14575437828 -15.4324308633 -117.706734271 -2.14575437828 -15.4424308633 -117.706734271 -2.14575437828 -15.4524308633 -117.706734271 -2.14575437828 -15.4624308633 -117.706734271 -2.14575437828 -15.4724308633 -117.706734271 -2.14575437828 -15.4824308633 -117.706734271 -2.14575437828 -15.4924308633 -117.706734271 -2.14575437828 -15.5024308633 -117.706734271 -2.14575437828 -15.5124308633 -117.706734271 -2.14575437828 -15.5224308633 -117.706734271 -2.14575437828 -15.5324308633 -117.706734271 -2.14575437828 -15.5424308633 -117.706734271 -2.14575437828 -15.5524308633 -117.706734271 -2.14575437828 -15.5624308633 -117.706734271 -2.14575437828 -15.5724308633 -117.706734271 -2.14575437828 -15.5824308633 -117.706734271 -2.14575437828 -15.5924308633 -117.706734271 -2.14575437828 -15.6024308633 -117.706734271 -2.14575437828 -15.6124308633 -117.706734271 -2.14575437828 -15.6224308633 -117.706734271 -2.14575437828 -15.6324308633 -117.706734271 -2.14575437828 -15.6424308633 -117.706734271 -2.14575437828 -15.6524308633 -117.706734271 -2.14575437828 -15.6624308633 -117.706734271 -2.14575437828 -15.6724308633 -117.706734271 -2.14575437828 -15.6824308633 -117.706734271 -2.14575437828 -15.6924308633 -117.706734271 -2.14575437828 -15.7024308633 -117.706734271 -2.14575437828 -15.7124308633 -117.706734271 -2.14575437828 -15.7224308633 -117.706734271 -2.14575437828 -15.7324308633 -117.706734271 -2.14575437828 -15.7424308633 -117.706734271 -2.14575437828 -15.7524308633 -57.3844006774 -2.14575437828 -15.7624308633 -14.5093522151 -2.14575437828 -15.7724308633 208.931908943 -2.14575437828 -15.7824308633 332.271892289 -2.14575437828 -15.7924308633 584.074764191 -2.14575437828 -15.8024308633 914.062070471 -2.14575437828 -15.8124308633 1053.03743991 -2.14575437828 -15.8224308633 1162.95704911 -2.14575437828 -15.8324308633 1206.91725762 -2.14575437828 -15.8424308633 1204.00076578 -2.14575437828 -15.8524308633 1093.96421786 -2.14575437828 -15.8624308633 932.70801773 -2.14575437828 -15.8724308633 795.258297536 -2.14575437828 -15.8824308633 711.285547588 -2.14575437828 -15.8924308633 618.237247984 -2.14575437828 -15.9024308633 540.721678559 -2.14575437828 -15.9124308633 476.592881279 -2.14575437828 -15.9224308633 423.44457302 -2.14575437828 -15.9324308633 392.055476578 -2.14575437828 -15.9424308633 382.910352369 -2.14575437828 -15.9524308633 392.420955483 -2.14575437828 -15.9624308633 405.198496311 -2.14575437828 -15.9724308633 424.211188939 -2.14575437828 -15.9824308633 457.457606132 -2.14575437828 -15.9924308633 502.484694174 -2.14575437828 -16.0024308633 564.078057316 -2.14575437828 -16.0124308633 639.327191328 -2.14575437828 -16.0224308633 684.041396148 -2.14575437828 -16.0324308633 740.311751283 -2.14575437828 -16.0424308633 793.586248315 -2.14575437828 -16.0524308633 841.050441732 -2.14575437828 -16.0624308633 870.84429563 -2.14575437828 -16.0724308633 877.978859126 -2.14575437828 -16.0824308633 875.334407644 -2.14575437828 -16.0924308633 878.128000035 -2.14575437828 -16.1024308633 914.051529442 -2.14575437828 -16.1124308633 834.829620075 -2.14575437828 -16.1224308633 783.28519455 -2.14575437828 -16.1324308633 766.688563712 -2.14575437828 -16.1424308633 722.504222559 -2.14575437828 -16.1524308633 697.523565983 -2.14575437828 -16.1624308633 630.485883757 -2.14575437828 -16.1724308633 546.541804999 -2.14575437828 -16.1824308633 469.766894703 -2.14575437828 -16.1924308633 435.361538886 -2.14575437828 -16.2024308633 413.779515737 -2.14575437828 -16.2124308633 398.517394112 -2.14575437828 -16.2224308633 368.099900025 -2.14575437828 -16.2324308633 346.930081021 -2.14575437828 -16.2424308633 319.679120396 -2.14575437828 -16.2524308633 295.869341862 -2.14575437828 -16.2624308633 285.364383323 -2.14575437828 -16.2724308633 283.785921243 -2.14575437828 -16.2824308633 293.191954593 -2.14575437828 -16.2924308633 292.747006271 -2.14575437828 -16.3024308633 298.624448934 -2.14575437828 -16.3124308633 306.075184738 -2.14575437828 -16.3224308633 329.154089903 -2.14575437828 -16.3324308633 347.224322554 -2.14575437828 -16.3424308633 366.415884315 -2.14575437828 -16.3524308633 373.410337695 -2.14575437828 -16.3624308633 379.176818861 -2.14575437828 -16.3724308633 384.016087219 -2.14575437828 -16.3824308633 397.220733731 -2.14575437828 -16.3924308633 386.762717973 -2.14575437828 -16.4024308633 386.553222639 -2.14575437828 -16.4124308633 351.253689748 -2.14575437828 -16.4224308633 337.747859773 -2.14575437828 -16.4324308633 318.942570569 -2.14575437828 -16.4424308633 304.849638928 -2.14575437828 -16.4524308633 293.952411958 -2.14575437828 -16.4624308633 266.375292139 -2.14575437828 -16.4724308633 255.772032878 -2.14575437828 -16.4824308633 247.011023519 -2.14575437828 -16.4924308633 239.468349626 -2.14575437828 -16.5024308633 225.252214217 -2.14575437828 -16.5124308633 218.493962509 -2.14575437828 -16.5224308633 213.504782864 -2.14575437828 -16.5324308633 205.922780502 -2.14575437828 -16.5424308633 201.19432363 -2.14575437828 -16.5524308633 166.557729859 -2.14575437828 -16.5624308633 165.360715432 -2.14575437828 -16.5724308633 189.407025826 -2.14575437828 -16.5824308633 166.839880982 -2.14575437828 -16.5924308633 155.657549617 -2.14575437828 -16.6024308633 145.699209503 -2.14575437828 -16.6124308633 141.813736297 -2.14575437828 -16.6224308633 137.90372553 -2.14575437828 -16.6324308633 119.960035639 -2.14575437828 -16.6424308633 90.2057765282 -2.14575437828 -16.6524308633 76.0797101032 -2.14575437828 -16.6624308633 66.0093023928 -2.14575437828 -16.6724308633 53.0266259115 -2.14575437828 -16.6824308633 40.1985036984 -2.14575437828 -16.6924308633 26.5317456602 -2.14575437828 -16.7024308633 7.88682807745 -2.14575437828 -16.7124308633 17.736323776 -2.14575437828 -16.7224308633 -2.56927733597 -2.14575437828 -16.7324308633 -6.6529354065 -2.14575437828 -16.7424308633 -35.4511793297 -2.14575437828 -16.7524308633 -57.3000592715 -2.14575437828 -16.7624308633 -71.0269100892 -2.14575437828 -16.7724308633 -83.9556327463 -2.14575437828 -16.7824308633 -86.6171031162 -2.14575437828 -16.7924308633 -103.5711027 -2.14575437828 -16.8024308633 -103.5711027 -2.14575437828 -16.8124308633 -103.5711027 -2.14575437828 -16.8224308633 -103.5711027 -2.14575437828 -16.8324308633 -103.5711027 -2.14575437828 -16.8424308633 -103.5711027 -2.14575437828 -16.8524308633 -103.5711027 -2.14575437828 -16.8624308633 -103.5711027 -2.14575437828 -16.8724308633 -103.5711027 -2.14575437828 -16.8824308633 -103.5711027 -2.14575437828 -16.8924308633 -103.5711027 -2.14575437828 -16.9024308633 -103.5711027 -2.14575437828 -16.9124308633 -103.5711027 -2.14575437828 -16.9224308633 -103.5711027 -2.14575437828 -16.9324308633 -103.5711027 -2.14575437828 -16.9424308633 -103.5711027 -2.14575437828 -16.9524308633 -103.5711027 -2.14575437828 -16.9624308633 -103.5711027 -2.14575437828 -16.9724308633 -103.5711027 -2.14575437828 -16.9824308633 -103.5711027 -2.14575437828 -16.9924308633 -103.5711027 -2.14575437828 -17.0024308633 -103.5711027 -2.14575437828 -17.0124308633 -103.5711027 -2.14575437828 -17.0224308633 -103.5711027 -2.14575437828 -17.0324308633 -103.5711027 -2.14575437828 -17.0424308633 -103.5711027 -2.14575437828 -17.0524308633 -103.5711027 -2.14575437828 -17.0624308633 -103.5711027 -2.14575437828 -17.0724308633 -103.5711027 -2.14575437828 -17.0824308633 -103.5711027 -2.14575437828 -17.0924308633 -103.5711027 -2.14575437828 -17.1024308633 -103.5711027 -2.14575437828 -17.1124308633 -103.5711027 -2.14575437828 -17.1224308633 -103.5711027 -2.14575437828 -17.1324308633 -103.5711027 -2.14575437828 -17.1424308633 -103.5711027 -2.14575437828 -17.1524308633 -103.5711027 -2.14575437828 -17.1624308633 -103.5711027 -2.14575437828 -17.1724308633 -103.5711027 -2.14575437828 -17.1824308633 -103.5711027 -2.14575437828 -17.1924308633 -103.5711027 -2.14575437828 -17.2024308633 -103.5711027 -2.14575437828 -17.2124308633 -103.5711027 -2.14575437828 -17.2224308633 -103.5711027 -2.14575437828 -17.2324308633 -103.5711027 -2.14575437828 -17.2424308633 -103.5711027 -2.14575437828 -17.2524308633 -103.5711027 -2.14575437828 -17.2624308633 -103.5711027 -2.14575437828 -17.2724308633 -103.5711027 -2.14575437828 -17.2824308633 -103.5711027 -2.14575437828 -17.2924308633 -103.5711027 -2.14575437828 -17.3024308633 -103.5711027 -2.14575437828 -17.3124308633 -103.5711027 -2.14575437828 -17.3224308633 -103.5711027 -2.14575437828 -17.3324308633 -103.5711027 -2.14575437828 -17.3424308633 -103.5711027 -2.14575437828 -17.3524308633 -103.5711027 -2.14575437828 -17.3624308633 -103.5711027 -2.14575437828 -17.3724308633 -103.5711027 -2.14575437828 -17.3824308633 -103.5711027 -2.14575437828 -17.3924308633 -103.5711027 -2.14575437828 -17.4024308633 -103.5711027 -2.14575437828 -17.4124308633 -103.5711027 -2.14575437828 -17.4224308633 -103.5711027 -2.14575437828 -17.4324308633 -103.5711027 -2.14575437828 -17.4424308633 -103.5711027 -2.14575437828 -17.4524308633 -103.5711027 -2.14575437828 -17.4624308633 -103.5711027 -2.14575437828 -17.4724308633 -103.5711027 -2.14575437828 -17.4824308633 -103.5711027 -2.14575437828 -17.4924308633 -103.5711027 -2.14575437828 -17.5024308633 -103.5711027 -2.14575437828 -17.5124308633 -103.5711027 -2.14575437828 -17.5224308633 -103.5711027 -2.14575437828 -17.5324308633 -103.5711027 -2.14575437828 -17.5424308633 -103.5711027 -2.14575437828 -17.5524308633 -103.5711027 -2.14575437828 -17.5624308633 -103.5711027 -2.14575437828 -17.5724308633 -103.5711027 -2.14575437828 -17.5824308633 -103.5711027 -2.14575437828 -17.5924308633 -103.5711027 -2.14575437828 -17.6024308633 -103.5711027 -2.14575437828 -17.6124308633 -103.5711027 -2.14575437828 -17.6224308633 -103.5711027 -2.14575437828 -17.6324308633 -103.5711027 -2.14575437828 -17.6424308633 -103.5711027 -2.14575437828 -17.6524308633 -103.5711027 -2.14575437828 -17.6624308633 -51.0493102689 -2.14575437828 -17.6724308633 -3.60391181628 -2.14575437828 -17.6824308633 178.994196099 -2.14575437828 -17.6924308633 608.876652068 -2.14575437828 -17.7024308633 830.498414367 -2.14575437828 -17.7124308633 937.689897337 -2.14575437828 -17.7224308633 1130.8933864 -2.14575437828 -17.7324308633 1205.1910678 -2.14575437828 -17.7424308633 1218.81936375 -2.14575437828 -17.7524308633 1132.41623811 -2.14575437828 -17.7624308633 984.679232497 -2.14575437828 -17.7724308633 834.554657836 -2.14575437828 -17.7824308633 750.404986365 -2.14575437828 -17.7924308633 621.743612151 -2.14575437828 -17.8024308633 566.334933676 -2.14575437828 -17.8124308633 507.065556094 -2.14575437828 -17.8224308633 463.526252064 -2.14575437828 -17.8324308633 437.068141994 -2.14575437828 -17.8424308633 428.94360299 -2.14575437828 -17.8524308633 432.833392399 -2.14575437828 -17.8624308633 445.295242033 -2.14575437828 -17.8724308633 464.580932163 -2.14575437828 -17.8824308633 496.080879354 -2.14575437828 -17.8924308633 532.043023914 -2.14575437828 -17.9024308633 573.286791196 -2.14575437828 -17.9124308633 609.682838687 -2.14575437828 -17.9224308633 655.427409595 -2.14575437828 -17.9324308633 701.725807623 -2.14575437828 -17.9424308633 749.009939206 -2.14575437828 -17.9524308633 786.480487623 -2.14575437828 -17.9624308633 816.459721516 -2.14575437828 -17.9724308633 840.51217954 -2.14575437828 -17.9824308633 874.502773168 -2.14575437828 -17.9924308633 862.205142832 -2.14575437828 -18.0024308633 848.144914852 -2.14575437828 -18.0124308633 839.753516645 -2.14575437828 -18.0224308633 818.545371753 -2.14575437828 -18.0324308633 779.229335003 -2.14575437828 -18.0424308633 729.940643049 -2.14575437828 -18.0524308633 686.54511176 -2.14575437828 -18.0624308633 612.155821133 -2.14575437828 -18.0724308633 548.889072921 -2.14575437828 -18.0824308633 540.092025136 -2.14575437828 -18.0924308633 466.282682433 -2.14575437828 -18.1024308633 435.623186637 -2.14575437828 -18.1124308633 408.913387283 -2.14575437828 -18.1224308633 389.397435056 -2.14575437828 -18.1324308633 379.992592446 -2.14575437828 -18.1424308633 372.000943098 -2.14575437828 -18.1524308633 357.301360112 -2.14575437828 -18.1624308633 351.948366869 -2.14575437828 -18.1724308633 342.07734942 -2.14575437828 -18.1824308633 342.54265455 -2.14575437828 -18.1924308633 338.020180319 -2.14575437828 -18.2024308633 332.202679656 -2.14575437828 -18.2124308633 329.240969899 -2.14575437828 -18.2224308633 324.194067436 -2.14575437828 -18.2324308633 323.420934588 -2.14575437828 -18.2424308633 309.661567652 -2.14575437828 -18.2524308633 309.631571565 -2.14575437828 -18.2624308633 303.382901517 -2.14575437828 -18.2724308633 291.955062405 -2.14575437828 -18.2824308633 281.014802851 -2.14575437828 -18.2924308633 278.186075876 -2.14575437828 -18.3024308633 276.442030584 -2.14575437828 -18.3124308633 268.828119176 -2.14575437828 -18.3224308633 262.028712809 -2.14575437828 -18.3324308633 255.318199514 -2.14575437828 -18.3424308633 256.866137627 -2.14575437828 -18.3524308633 250.27800834 -2.14575437828 -18.3624308633 241.961995294 -2.14575437828 -18.3724308633 238.037227857 -2.14575437828 -18.3824308633 234.638088772 -2.14575437828 -18.3924308633 231.229054518 -2.14575437828 -18.4024308633 224.014482335 -2.14575437828 -18.4124308633 220.048677247 -2.14575437828 -18.4224308633 213.681231934 -2.14575437828 -18.4324308633 205.000379209 -2.14575437828 -18.4424308633 198.586025916 -2.14575437828 -18.4524308633 189.850021597 -2.14575437828 -18.4624308633 181.340587491 -2.14575437828 -18.4724308633 172.460991886 -2.14575437828 -18.4824308633 167.641819512 -2.14575437828 -18.4924308633 159.348959359 -2.14575437828 -18.5024308633 145.564520123 -2.14575437828 -18.5124308633 127.60376359 -2.14575437828 -18.5224308633 103.543903341 -2.14575437828 -18.5324308633 78.5038269047 -2.14575437828 -18.5424308633 60.2438322962 -2.14575437828 -18.5524308633 48.8335418822 -2.14575437828 -18.5624308633 44.2698557436 -2.14575437828 -18.5724308633 43.5875478516 -2.14575437828 -18.5824308633 32.7580474435 -2.14575437828 -18.5924308633 -17.723263655 -2.14575437828 -18.6024308633 -37.8114536002 -2.14575437828 -18.6124308633 -36.09619035 -2.14575437828 -18.6224308633 -22.7861326087 -2.14575437828 -18.6324308633 -8.72123016456 -2.14575437828 -18.6424308633 -4.19502560492 -2.14575437828 -18.6524308633 -19.5442002015 -2.14575437828 -18.6624308633 -35.1053220499 -2.14575437828 -18.6724308633 -60.5542011864 -2.14575437828 -18.6824308633 -84.2947284674 -2.14575437828 -18.6924308633 -87.3515662773 -2.14575437828 -18.7024308633 -112.62383496 -2.14575437828 -18.7124308633 -124.816670233 -2.14575437828 -18.7224308633 -133.107623638 -2.14575437828 -18.7324308633 -135.311409804 -2.14575437828 -18.7424308633 -89.1081867113 -2.14575437828 -18.7524308633 -64.9432315073 -2.14575437828 -18.7624308633 -75.9670889086 -2.14575437828 -18.7724308633 -75.9670889086 -2.14575437828 -18.7824308633 -75.9670889086 -2.14575437828 -18.7924308633 -75.9670889086 -2.14575437828 -18.8024308633 -75.9670889086 -2.14575437828 -18.8124308633 -75.9670889086 -2.14575437828 -18.8224308633 -75.9670889086 -2.14575437828 -18.8324308633 -75.9670889086 -2.14575437828 -18.8424308633 -75.9670889086 -2.14575437828 -18.8524308633 -75.9670889086 -2.14575437828 -18.8624308633 -75.9670889086 -2.14575437828 -18.8724308633 -75.9670889086 -2.14575437828 -18.8824308633 -75.9670889086 -2.14575437828 -18.8924308633 -75.9670889086 -2.14575437828 -18.9024308633 -75.9670889086 -2.14575437828 -18.9124308633 -75.9670889086 -2.14575437828 -18.9224308633 -75.9670889086 -2.14575437828 -18.9324308633 -75.9670889086 -2.14575437828 -18.9424308633 -75.9670889086 -2.14575437828 -18.9524308633 -75.9670889086 -2.14575437828 -18.9624308633 -75.9670889086 -2.14575437828 -18.9724308633 -75.9670889086 -2.14575437828 -18.9824308633 -75.9670889086 -2.14575437828 -18.9924308633 -75.9670889086 -2.14575437828 -19.0024308633 -75.9670889086 -2.14575437828 -19.0124308633 -75.9670889086 -2.14575437828 -19.0224308633 -75.9670889086 -2.14575437828 -19.0324308633 -75.9670889086 -2.14575437828 -19.0424308633 -75.9670889086 -2.14575437828 -19.0524308633 -75.9670889086 -2.14575437828 -19.0624308633 -75.9670889086 -2.14575437828 -19.0724308633 -75.9670889086 -2.14575437828 -19.0824308633 -75.9670889086 -2.14575437828 -19.0924308633 -75.9670889086 -2.14575437828 -19.1024308633 -75.9670889086 -2.14575437828 -19.1124308633 -75.9670889086 -2.14575437828 -19.1224308633 -75.9670889086 -2.14575437828 -19.1324308633 -75.9670889086 -2.14575437828 -19.1424308633 -75.9670889086 -2.14575437828 -19.1524308633 -75.9670889086 -2.14575437828 -19.1624308633 -75.9670889086 -2.14575437828 -19.1724308633 -75.9670889086 -2.14575437828 -19.1824308633 -75.9670889086 -2.14575437828 -19.1924308633 -75.9670889086 -2.14575437828 -19.2024308633 -75.9670889086 -2.14575437828 -19.2124308633 -75.9670889086 -2.14575437828 -19.2224308633 -75.9670889086 -2.14575437828 -19.2324308633 -75.9670889086 -2.14575437828 -19.2424308633 -75.9670889086 -2.14575437828 -19.2524308633 -75.9670889086 -2.14575437828 -19.2624308633 -75.9670889086 -2.14575437828 -19.2724308633 -75.9670889086 -2.14575437828 -19.2824308633 -75.9670889086 -2.14575437828 -19.2924308633 -75.9670889086 -2.14575437828 -19.3024308633 -75.9670889086 -2.14575437828 -19.3124308633 -75.9670889086 -2.14575437828 -19.3224308633 -75.9670889086 -2.14575437828 -19.3324308633 -75.9670889086 -2.14575437828 -19.3424308633 -75.9670889086 -2.14575437828 -19.3524308633 -75.9670889086 -2.14575437828 -19.3624308633 -75.9670889086 -2.14575437828 -19.3724308633 -75.9670889086 -2.14575437828 -19.3824308633 -75.9670889086 -2.14575437828 -19.3924308633 -75.9670889086 -2.14575437828 -19.4024308633 -75.9670889086 -2.14575437828 -19.4124308633 -75.9670889086 -2.14575437828 -19.4224308633 -75.9670889086 -2.14575437828 -19.4324308633 -75.9670889086 -2.14575437828 -19.4424308633 -75.9670889086 -2.14575437828 -19.4524308633 -75.9670889086 -2.14575437828 -19.4624308633 -75.9670889086 -2.14575437828 -19.4724308633 -75.9670889086 -2.14575437828 -19.4824308633 -75.9670889086 -2.14575437828 -19.4924308633 -75.9670889086 -2.14575437828 -19.5024308633 -75.9670889086 -2.14575437828 -19.5124308633 -75.9670889086 -2.14575437828 -19.5224308633 -75.9670889086 -2.14575437828 -19.5324308633 -75.9670889086 -2.14575437828 -19.5424308633 -75.9670889086 -2.14575437828 -19.5524308633 45.6958173848 -2.14575437828 -19.5624308633 149.990937872 -2.14575437828 -19.5724308633 247.772218309 -2.14575437828 -19.5824308633 415.246504734 -2.14575437828 -19.5924308633 609.773416354 -2.14575437828 -19.6024308633 715.411131559 -2.14575437828 -19.6124308633 865.000705624 -2.14575437828 -19.6224308633 925.666229418 -2.14575437828 -19.6324308633 975.682107164 -2.14575437828 -19.6424308633 954.759145241 -2.14575437828 -19.6524308633 882.827785511 -2.14575437828 -19.6624308633 800.210612972 -2.14575437828 -19.6724308633 703.983584871 -2.14575437828 -19.6824308633 628.980031821 -2.14575437828 -19.6924308633 567.492340066 -2.14575437828 -19.7024308633 519.11739414 -2.14575437828 -19.7124308633 468.452890997 -2.14575437828 -19.7224308633 448.186313846 -2.14575437828 -19.7324308633 428.69942864 -2.14575437828 -19.7424308633 423.894570886 -2.14575437828 -19.7524308633 445.815961737 -2.14575437828 -19.7624308633 466.428291296 -2.14575437828 -19.7724308633 494.265751525 -2.14575437828 -19.7824308633 530.167537414 -2.14575437828 -19.7924308633 585.706972599 -2.14575437828 -19.8024308633 633.824632649 -2.14575437828 -19.8124308633 679.901418012 -2.14575437828 -19.8224308633 730.489590726 -2.14575437828 -19.8324308633 770.312587024 -2.14575437828 -19.8424308633 795.132779638 -2.14575437828 -19.8524308633 808.817820225 -2.14575437828 -19.8624308633 805.991766692 -2.14575437828 -19.8724308633 810.890510788 -2.14575437828 -19.8824308633 801.526239811 -2.14575437828 -19.8924308633 771.34867632 -2.14575437828 -19.9024308633 752.658226347 -2.14575437828 -19.9124308633 730.83085614 -2.14575437828 -19.9224308633 707.298308724 -2.14575437828 -19.9324308633 701.812848057 -2.14575437828 -19.9424308633 675.519435332 -2.14575437828 -19.9524308633 614.364270804 -2.14575437828 -19.9624308633 567.133979117 -2.14575437828 -19.9724308633 520.687819788 -2.14575437828 -19.9824308633 484.945592071 -2.14575437828 -19.9924308633 456.561252517 -2.14575437828 -20.0024308633 427.297123619 -2.14575437828 -20.0124308633 406.472146643 -2.14575437828 -20.0224308633 394.458525307 -2.14575437828 -20.0324308633 377.269073608 -2.14575437828 -20.0424308633 362.925344373 -2.14575437828 -20.0524308633 351.030181337 -2.14575437828 -20.0624308633 344.242433483 -2.14575437828 -20.0724308633 343.813048093 -2.14575437828 -20.0824308633 328.204408071 -2.14575437828 -20.0924308633 339.702420901 -2.14575437828 -20.1024308633 354.921593658 -2.14575437828 -20.1124308633 369.926860631 -2.14575437828 -20.1224308633 377.30522223 -2.14575437828 -20.1324308633 370.786523351 -2.14575437828 -20.1424308633 366.053268068 -2.14575437828 -20.1524308633 357.70240542 -2.14575437828 -20.1624308633 350.458982304 -2.14575437828 -20.1724308633 342.056286576 -2.14575437828 -20.1824308633 329.982969696 -2.14575437828 -20.1924308633 318.834145334 -2.14575437828 -20.2024308633 308.0732841 -2.14575437828 -20.2124308633 284.299809291 -2.14575437828 -20.2224308633 276.176461216 -2.14575437828 -20.2324308633 265.11964219 -2.14575437828 -20.2424308633 262.524342923 -2.14575437828 -20.2524308633 251.919268192 -2.14575437828 -20.2624308633 243.759166891 -2.14575437828 -20.2724308633 232.872905787 -2.14575437828 -20.2824308633 225.025627498 -2.14575437828 -20.2924308633 218.455668048 -2.14575437828 -20.3024308633 208.462562861 -2.14575437828 -20.3124308633 197.592838489 -2.14575437828 -20.3224308633 198.630042651 -2.14575437828 -20.3324308633 194.315393227 -2.14575437828 -20.3424308633 189.36820722 -2.14575437828 -20.3524308633 175.540661301 -2.14575437828 -20.3624308633 166.842614625 -2.14575437828 -20.3724308633 163.110451407 -2.14575437828 -20.3824308633 163.075932278 -2.14575437828 -20.3924308633 159.725452446 -2.14575437828 -20.4024308633 138.138554661 -2.14575437828 -20.4124308633 143.257619526 -2.14575437828 -20.4224308633 141.368490844 -2.14575437828 -20.4324308633 134.757209075 -2.14575437828 -20.4424308633 112.914412748 -2.14575437828 -20.4524308633 106.566926433 -2.14575437828 -20.4624308633 93.0221456533 -2.14575437828 -20.4724308633 87.6955167761 -2.14575437828 -20.4824308633 71.0415449466 -2.14575437828 -20.4924308633 55.2102290507 -2.14575437828 -20.5024308633 34.8555483336 -2.14575437828 -20.5124308633 7.35751269131 -2.14575437828 -20.5224308633 -7.32747355936 -2.14575437828 -20.5324308633 -16.2210096908 -2.14575437828 -20.5424308633 -23.7172131923 -2.14575437828 -20.5524308633 -33.3114638997 -2.14575437828 -20.5624308633 -45.3587481664 -2.14575437828 -20.5724308633 -52.8103662289 -2.14575437828 -20.5824308633 -69.516068234 -2.14575437828 -20.5924308633 -66.5379702153 -2.14575437828 -20.6024308633 -73.2813289353 -2.14575437828 -20.6124308633 -76.3493600373 -2.14575437828 -20.6224308633 -121.179609071 -2.14575437828 -20.6324308633 -91.3246858433 -2.14575437828 -20.6424308633 -103.720570484 -2.14575437828 -20.6524308633 -103.720570484 -2.14575437828 -20.6624308633 -103.720570484 -2.14575437828 -20.6724308633 -103.720570484 -2.14575437828 -20.6824308633 -103.720570484 -2.14575437828 -20.6924308633 -103.720570484 -2.14575437828 -20.7024308633 -103.720570484 -2.14575437828 -20.7124308633 -103.720570484 -2.14575437828 -20.7224308633 -103.720570484 -2.14575437828 -20.7324308633 -103.720570484 -2.14575437828 -20.7424308633 -103.720570484 -2.14575437828 -20.7524308633 -103.720570484 -2.14575437828 -20.7624308633 -103.720570484 -2.14575437828 -20.7724308633 -103.720570484 -2.14575437828 -20.7824308633 -103.720570484 -2.14575437828 -20.7924308633 -103.720570484 -2.14575437828 -20.8024308633 -103.720570484 -2.14575437828 -20.8124308633 -103.720570484 -2.14575437828 -20.8224308633 -103.720570484 -2.14575437828 -20.8324308633 -103.720570484 -2.14575437828 -20.8424308633 -103.720570484 -2.14575437828 -20.8524308633 -103.720570484 -2.14575437828 -20.8624308633 -103.720570484 -2.14575437828 -20.8724308633 -103.720570484 -2.14575437828 -20.8824308633 -103.720570484 -2.14575437828 -20.8924308633 -103.720570484 -2.14575437828 -20.9024308633 -103.720570484 -2.14575437828 -20.9124308633 -103.720570484 -2.14575437828 -20.9224308633 -103.720570484 -2.14575437828 -20.9324308633 -103.720570484 -2.14575437828 -20.9424308633 -103.720570484 -2.14575437828 -20.9524308633 -103.720570484 -2.14575437828 -20.9624308633 -103.720570484 -2.14575437828 -20.9724308633 -103.720570484 -2.14575437828 -20.9824308633 -103.720570484 -2.14575437828 -20.9924308633 -103.720570484 -2.14575437828 -21.0024308633 -103.720570484 -2.14575437828 -21.0124308633 -103.720570484 -2.14575437828 -21.0224308633 -103.720570484 -2.14575437828 -21.0324308633 -103.720570484 -2.14575437828 -21.0424308633 -103.720570484 -2.14575437828 -21.0524308633 -103.720570484 -2.14575437828 -21.0624308633 -103.720570484 -2.14575437828 -21.0724308633 -103.720570484 -2.14575437828 -21.0824308633 -103.720570484 -2.14575437828 -21.0924308633 -103.720570484 -2.14575437828 -21.1024308633 -103.720570484 -2.14575437828 -21.1124308633 -103.720570484 -2.14575437828 -21.1224308633 -103.720570484 -2.14575437828 -21.1324308633 -103.720570484 -2.14575437828 -21.1424308633 -103.720570484 -2.14575437828 -21.1524308633 -103.720570484 -2.14575437828 -21.1624308633 -103.720570484 -2.14575437828 -21.1724308633 -103.720570484 -2.14575437828 -21.1824308633 -103.720570484 -2.14575437828 -21.1924308633 -103.720570484 -2.14575437828 -21.2024308633 -103.720570484 -2.14575437828 -21.2124308633 -103.720570484 -2.14575437828 -21.2224308633 -103.720570484 -2.14575437828 -21.2324308633 -103.720570484 -2.14575437828 -21.2424308633 -103.720570484 -2.14575437828 -21.2524308633 -103.720570484 -2.14575437828 -21.2624308633 -103.720570484 -2.14575437828 -21.2724308633 -103.720570484 -2.14575437828 -21.2824308633 -103.720570484 -2.14575437828 -21.2924308633 -103.720570484 -2.14575437828 -21.3024308633 -103.720570484 -2.14575437828 -21.3124308633 -103.720570484 -2.14575437828 -21.3224308633 -103.720570484 -2.14575437828 -21.3324308633 -103.720570484 -2.14575437828 -21.3424308633 -103.720570484 -2.14575437828 -21.3524308633 -103.720570484 -2.14575437828 -21.3624308633 -103.720570484 -2.14575437828 -21.3724308633 -103.720570484 -2.14575437828 -21.3824308633 -103.720570484 -2.14575437828 -21.3924308633 -103.720570484 -2.14575437828 -21.4024308633 -103.720570484 -2.14575437828 -21.4124308633 -103.720570484 -2.14575437828 -21.4224308633 -103.720570484 -2.14575437828 -21.4324308633 -103.720570484 -2.14575437828 -21.4424308633 -103.720570484 -2.14575437828 -21.4524308633 -103.720570484 -2.14575437828 -21.4624308633 -103.720570484 -2.14575437828 -21.4724308633 17.7834440355 -2.14575437828 -21.4824308633 124.60653102 -2.14575437828 -21.4924308633 216.459494774 -2.14575437828 -21.5024308633 601.035852817 -2.14575437828 -21.5124308633 928.618572733 -2.14575437828 -21.5224308633 982.891824193 -2.14575437828 -21.5324308633 1040.18662127 -2.14575437828 -21.5424308633 1055.36021708 -2.14575437828 -21.5524308633 963.92951686 -2.14575437828 -21.5624308633 905.939268098 -2.14575437828 -21.5724308633 842.718809911 -2.14575437828 -21.5824308633 805.582079756 -2.14575437828 -21.5924308633 738.02692766 -2.14575437828 -21.6024308633 662.321085965 -2.14575437828 -21.6124308633 598.021470199 -2.14575437828 -21.6224308633 555.177735152 -2.14575437828 -21.6324308633 528.046660277 -2.14575437828 -21.6424308633 490.80549461 -2.14575437828 -21.6524308633 462.229373315 -2.14575437828 -21.6624308633 447.309883301 -2.14575437828 -21.6724308633 442.90206247 -2.14575437828 -21.6824308633 441.32804754 -2.14575437828 -21.6924308633 448.408809857 -2.14575437828 -21.7024308633 471.208005016 -2.14575437828 -21.7124308633 505.831841483 -2.14575437828 -21.7224308633 542.045077128 -2.14575437828 -21.7324308633 598.506055814 -2.14575437828 -21.7424308633 663.859411407 -2.14575437828 -21.7524308633 725.689483421 -2.14575437828 -21.7624308633 768.178766026 -2.14575437828 -21.7724308633 801.783958573 -2.14575437828 -21.7824308633 872.083075082 -2.14575437828 -21.7924308633 887.004413254 -2.14575437828 -21.8024308633 914.667239688 -2.14575437828 -21.8124308633 857.360685783 -2.14575437828 -21.8224308633 828.5219675 -2.14575437828 -21.8324308633 793.03152894 -2.14575437828 -21.8424308633 730.33701716 -2.14575437828 -21.8524308633 688.987675816 -2.14575437828 -21.8624308633 667.148756009 -2.14575437828 -21.8724308633 608.914479586 -2.14575437828 -21.8824308633 567.268871363 -2.14575437828 -21.8924308633 527.539901705 -2.14575437828 -21.9024308633 496.154029241 -2.14575437828 -21.9124308633 462.989672962 -2.14575437828 -21.9224308633 445.655951144 -2.14575437828 -21.9324308633 407.315564332 -2.14575437828 -21.9424308633 389.526844936 -2.14575437828 -21.9524308633 372.784010037 -2.14575437828 -21.9624308633 366.463530109 -2.14575437828 -21.9724308633 362.17292768 -2.14575437828 -21.9824308633 359.298773436 -2.14575437828 -21.9924308633 350.510118308 -2.14575437828 -22.0024308633 347.546527781 -2.14575437828 -22.0124308633 363.988979913 -2.14575437828 -22.0224308633 380.451547883 -2.14575437828 -22.0324308633 388.602365343 -2.14575437828 -22.0424308633 386.949654048 -2.14575437828 -22.0524308633 395.657300325 -2.14575437828 -22.0624308633 402.933986849 -2.14575437828 -22.0724308633 407.137135283 -2.14575437828 -22.0824308633 414.621886523 -2.14575437828 -22.0924308633 417.704822711 -2.14575437828 -22.1024308633 415.269453853 -2.14575437828 -22.1124308633 416.183133977 -2.14575437828 -22.1224308633 405.774560889 -2.14575437828 -22.1324308633 390.637304204 -2.14575437828 -22.1424308633 381.448184535 -2.14575437828 -22.1524308633 364.059299365 -2.14575437828 -22.1624308633 349.285802077 -2.14575437828 -22.1724308633 337.731115566 -2.14575437828 -22.1824308633 322.99332363 -2.14575437828 -22.1924308633 308.855160504 -2.14575437828 -22.2024308633 303.768306737 -2.14575437828 -22.2124308633 293.546640068 -2.14575437828 -22.2224308633 280.991126568 -2.14575437828 -22.2324308633 266.722424095 -2.14575437828 -22.2424308633 253.640664801 -2.14575437828 -22.2524308633 240.747849619 -2.14575437828 -22.2624308633 221.7429579 -2.14575437828 -22.2724308633 210.254637007 -2.14575437828 -22.2824308633 193.080700329 -2.14575437828 -22.2924308633 172.009448024 -2.14575437828 -22.3024308633 162.24258693 -2.14575437828 -22.3124308633 153.404786971 -2.14575437828 -22.3224308633 147.581622446 -2.14575437828 -22.3324308633 131.127380017 -2.14575437828 -22.3424308633 100.090523798 -2.14575437828 -22.3524308633 99.8309621933 -2.14575437828 -22.3624308633 87.0149173913 -2.14575437828 -22.3724308633 68.8694091193 -2.14575437828 -22.3824308633 52.9264810638 -2.14575437828 -22.3924308633 32.4540374164 -2.14575437828 -22.4024308633 13.8363171707 -2.14575437828 -22.4124308633 3.8247892907 -2.14575437828 -22.4224308633 -1.34985572341 -2.14575437828 -22.4324308633 -9.28244138316 -2.14575437828 -22.4424308633 -6.51131076847 -2.14575437828 -22.4524308633 -7.82890345515 -2.14575437828 -22.4624308633 -8.81557087848 -2.14575437828 -22.4724308633 -42.7386020848 -2.14575437828 -22.4824308633 -11.3938686868 -2.14575437828 -22.4924308633 -27.9928978818 -2.14575437828 -22.5024308633 -61.6035491976 -2.14575437828 -22.5124308633 -76.4140460297 -2.14575437828 -22.5224308633 -89.2235707603 -2.14575437828 -22.5324308633 -78.2407885723 -2.14575437828 -22.5424308633 -106.248999821 -2.14575437828 -22.5524308633 -97.242093162 -2.14575437828 -22.5624308633 -139.519688895 -2.14575437828 -22.5724308633 -139.519688895 -2.14575437828 -22.5824308633 -139.519688895 -2.14575437828 -22.5924308633 -139.519688895 -2.14575437828 -22.6024308633 -139.519688895 -2.14575437828 -22.6124308633 -139.519688895 -2.14575437828 -22.6224308633 -139.519688895 -2.14575437828 -22.6324308633 -139.519688895 -2.14575437828 -22.6424308633 -139.519688895 -2.14575437828 -22.6524308633 -139.519688895 -2.14575437828 -22.6624308633 -139.519688895 -2.14575437828 -22.6724308633 -139.519688895 -2.14575437828 -22.6824308633 -139.519688895 -2.14575437828 -22.6924308633 -139.519688895 -2.14575437828 -22.7024308633 -139.519688895 -2.14575437828 -22.7124308633 -139.519688895 -2.14575437828 -22.7224308633 -139.519688895 -2.14575437828 -22.7324308633 -139.519688895 -2.14575437828 -22.7424308633 -139.519688895 -2.14575437828 -22.7524308633 -139.519688895 -2.14575437828 -22.7624308633 -139.519688895 -2.14575437828 -22.7724308633 -139.519688895 -2.14575437828 -22.7824308633 -139.519688895 -2.14575437828 -22.7924308633 -139.519688895 -2.14575437828 -22.8024308633 -139.519688895 -2.14575437828 -22.8124308633 -139.519688895 -2.14575437828 -22.8224308633 -139.519688895 -2.14575437828 -22.8324308633 -139.519688895 -2.14575437828 -22.8424308633 -139.519688895 -2.14575437828 -22.8524308633 -139.519688895 -2.14575437828 -22.8624308633 -139.519688895 -2.14575437828 -22.8724308633 -139.519688895 -2.14575437828 -22.8824308633 -139.519688895 -2.14575437828 -22.8924308633 -139.519688895 -2.14575437828 -22.9024308633 -139.519688895 -2.14575437828 -22.9124308633 -139.519688895 -2.14575437828 -22.9224308633 -139.519688895 -2.14575437828 -22.9324308633 -139.519688895 -2.14575437828 -22.9424308633 -139.519688895 -2.14575437828 -22.9524308633 -139.519688895 -2.14575437828 -22.9624308633 -139.519688895 -2.14575437828 -22.9724308633 -139.519688895 -2.14575437828 -22.9824308633 -139.519688895 -2.14575437828 -22.9924308633 -139.519688895 -2.14575437828 -23.0024308633 -139.519688895 -2.14575437828 -23.0124308633 -139.519688895 -2.14575437828 -23.0224308633 -139.519688895 -2.14575437828 -23.0324308633 -139.519688895 -2.14575437828 -23.0424308633 -139.519688895 -2.14575437828 -23.0524308633 -139.519688895 -2.14575437828 -23.0624308633 -139.519688895 -2.14575437828 -23.0724308633 -139.519688895 -2.14575437828 -23.0824308633 -139.519688895 -2.14575437828 -23.0924308633 -139.519688895 -2.14575437828 -23.1024308633 -139.519688895 -2.14575437828 -23.1124308633 -139.519688895 -2.14575437828 -23.1224308633 -139.519688895 -2.14575437828 -23.1324308633 -139.519688895 -2.14575437828 -23.1424308633 -139.519688895 -2.14575437828 -23.1524308633 -139.519688895 -2.14575437828 -23.1624308633 -139.519688895 -2.14575437828 -23.1724308633 -139.519688895 -2.14575437828 -23.1824308633 -139.519688895 -2.14575437828 -23.1924308633 -139.519688895 -2.14575437828 -23.2024308633 -139.519688895 -2.14575437828 -23.2124308633 -139.519688895 -2.14575437828 -23.2224308633 -139.519688895 -2.14575437828 -23.2324308633 -139.519688895 -2.14575437828 -23.2424308633 -139.519688895 -2.14575437828 -23.2524308633 -139.519688895 -2.14575437828 -23.2624308633 -139.519688895 -2.14575437828 -23.2724308633 -139.519688895 -2.14575437828 -23.2824308633 -139.519688895 -2.14575437828 -23.2924308633 -139.519688895 -2.14575437828 -23.3024308633 -139.519688895 -2.14575437828 -23.3124308633 -139.519688895 -2.14575437828 -23.3224308633 -139.519688895 -2.14575437828 -23.3324308633 -139.519688895 -2.14575437828 -23.3424308633 -139.519688895 -2.14575437828 -23.3524308633 -139.519688895 -2.14575437828 -23.3624308633 -139.519688895 -2.14575437828 -23.3724308633 -139.519688895 -2.14575437828 -23.3824308633 -139.519688895 -2.14575437828 -23.3924308633 -139.519688895 -2.14575437828 -23.4024308633 116.788982497 -2.14575437828 -23.4124308633 183.21374893 -2.14575437828 -23.4224308633 366.867672489 -2.14575437828 -23.4324308633 518.160815075 -2.14575437828 -23.4424308633 923.164092291 -2.14575437828 -23.4524308633 1098.01243492 -2.14575437828 -23.4624308633 1225.71965115 -2.14575437828 -23.4724308633 1237.82698903 -2.14575437828 -23.4824308633 1159.895292 -2.14575437828 -23.4924308633 1080.19635543 -2.14575437828 -23.5024308633 931.976920277 -2.14575437828 -23.5124308633 804.03266588 -2.14575437828 -23.5224308633 704.964923331 -2.14575437828 -23.5324308633 605.42489375 -2.14575437828 -23.5424308633 541.101203435 -2.14575437828 -23.5524308633 495.754920455 -2.14575437828 -23.5624308633 461.058777271 -2.14575437828 -23.5724308633 436.194739939 12.9920361341 -23.5824308633 418.227305701 13.5101180834 -23.5924308633 407.572642176 13.4321496838 -23.6024308633 415.308260841 12.503299576 -23.6124308633 425.166609486 12.6008986645 -23.6224308633 453.15173881 11.7062720956 -23.6324308633 490.600052824 11.5085537972 -23.6424308633 536.182079297 10.7846376185 -23.6524308633 596.806862787 14.8543099918 -23.6624308633 655.590656398 14.8543099918 -23.6724308633 719.410384538 14.8543099918 -23.6824308633 777.202969501 14.8543099918 -23.6924308633 816.909957325 14.8543099918 -23.7024308633 838.103138299 14.8543099918 -23.7124308633 852.438220786 14.8543099918 -23.7224308633 875.404489 14.8543099918 -23.7324308633 876.709838002 14.8543099918 -23.7424308633 876.157108315 14.8543099918 -23.7524308633 867.695446274 14.8543099918 -23.7624308633 818.49982519 14.8543099918 -23.7724308633 767.089183062 14.8543099918 -23.7824308633 732.609071999 14.8543099918 -23.7924308633 673.43832439 14.8543099918 -23.8024308633 595.686068235 14.8543099918 -23.8124308633 522.380648563 14.8543099918 -23.8224308633 527.515917918 14.8543099918 -23.8324308633 472.021569093 14.8543099918 diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_fine.csv b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_fine.csv deleted file mode 100644 index 011ce961eba8..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_fine.csv +++ /dev/null @@ -1,10122 +0,0 @@ -time (0.0,0.093) (0.0,0.299) -1e-06 0.0 0.0 -2e-06 0.0 0.0 -3e-06 0.0 0.0 -0.001003 -134.419181167 0.0 -0.00249059752038 -54.7257581525 0.0 -0.00349059752038 -19.0305328057 0.0 -0.00449059752038 -4.59013940313 0.0 -0.00567189282577 6.97044931454 0.0 -0.00667189282577 19.636297883 0.0 -0.00767189282577 31.5380880946 0.0 -0.00867189282577 37.4494776424 0.0 -0.00967189282577 58.0970097161 0.0 -0.0106718928258 62.90162204 0.0 -0.0116718928258 63.6419294913 0.0 -0.0126718928258 62.8546968586 0.0 -0.0136718928258 59.20968481 0.0 -0.0149875392141 56.6080507446 0.0 -0.0161651974993 52.3266139375 0.0 -0.0171912096587 46.578950386 0.0 -0.0181912096587 40.9412883296 0.0 -0.0191912096587 36.4667617413 0.0 -0.0201912096587 33.7072535261 0.0 -0.0211912096587 32.5115768809 0.0 -0.0221912096587 32.6766839177 0.0 -0.0231912096587 33.738623925 0.0 -0.0241912096587 35.4810874542 0.0 -0.0251912096587 36.0190703636 0.0 -0.0261912096587 36.887171785 0.0 -0.0271912096587 36.9079000591 0.0 -0.0281912096587 36.3246662732 0.0 -0.0291912096587 35.236853848 0.0 -0.0301912096587 33.9023086559 0.0 -0.0311912096587 32.1009004657 0.0 -0.0321912096587 30.2132899638 0.0 -0.0331912096587 28.6229565668 0.0 -0.0341912096587 27.7358051341 0.0 -0.0351912096587 27.8846366525 0.0 -0.0361912096587 29.2639430388 0.0 -0.0371912096587 31.8259729938 0.0 -0.0381912096587 35.4981003464 0.0 -0.0391912096587 39.6271209136 0.0 -0.0401912096587 43.1598274699 0.0 -0.0411912096587 45.0795527633 0.0 -0.0421912096587 45.1268654465 0.0 -0.0431912096587 43.3862867298 0.0 -0.0441912096587 40.2256543549 0.0 -0.0451912096587 35.6542936256 0.0 -0.0461912096587 30.9290577377 0.0 -0.0471912096587 26.7845880563 0.0 -0.0481912096587 23.6096832523 0.0 -0.0491912096587 20.8824378851 0.0 -0.0501912096587 19.8548308151 0.0 -0.0511912096587 19.9794169085 0.0 -0.0521912096587 21.4290162201 0.0 -0.0531912096587 23.1697492328 0.0 -0.0541912096587 24.159368547 0.0 -0.0551912096587 23.6719212506 0.0 -0.0561912096587 22.9018815027 0.0 -0.0571912096587 23.9930915814 0.0 -0.0581912096587 24.7608394039 0.0 -0.0591912096587 25.1585262287 0.0 -0.0601912096587 25.500786039 0.0 -0.0611912096587 25.8199053699 0.0 -0.0621952490654 26.1366418282 0.0 -0.0643953557023 27.2265865604 0.0 -0.0654954089798 26.9890169883 0.0 -0.0664954089798 26.9956945306 0.0 -0.0674954089798 27.1493651663 0.0 -0.0684954089798 27.3669009039 0.0 -0.0694954089798 27.9444041663 0.0 -0.0704954089798 29.2310631742 0.0 -0.0714954089798 31.4098789345 0.0 -0.0724954089798 34.1954855911 0.0 -0.0734954089798 37.7606892011 0.0 -0.0744954089798 41.7981357089 0.0 -0.0754954089798 38.7881944444 0.0 -0.0764954089798 38.0833513508 0.0 -0.0774954089798 33.2244231136 0.0 -0.0784954089798 32.2555320064 0.0 -0.0794954089798 35.1238816837 0.0 -0.0804954089798 39.9389151926 0.0 -0.0814954089798 45.2661568998 0.0 -0.0827639942261 49.5810022043 0.0 -0.0837639942261 54.0877326559 0.0 -0.0847639942261 57.6280707709 0.0 -0.0857639942261 60.2222164927 0.0 -0.0867639942261 62.0860651152 0.0 -0.0877639942261 63.5747293169 0.0 -0.0887639942261 64.9222492278 0.0 -0.0897639942261 66.0020966959 0.0 -0.0907639942261 66.856792123 0.0 -0.0917792894574 67.5885575147 0.0 -0.0927792894574 69.1069330006 0.0 -0.0955105076999 71.3457034328 0.0 -0.0973462337281 72.7500122104 0.0 -0.0985525579512 74.0757256505 0.0 -0.10098648562 75.6320185837 0.0 -0.102420845301 77.4174212949 0.0 -0.103820852546 76.3156389077 0.0 -0.104820852546 74.1539111014 0.0 -0.105820852546 71.4526295604 0.0 -0.106820852546 67.8878930808 0.0 -0.107820852546 63.5898680229 0.0 -0.108820852546 59.0529595132 0.0 -0.109820852546 54.7673159652 0.0 -0.110820852546 50.9221702045 0.0 -0.111820852546 47.8082259844 0.0 -0.112820852546 45.5179694282 0.0 -0.113820852546 43.8426077818 0.0 -0.114820852546 43.4879308363 0.0 -0.115820852546 43.7049900145 0.0 -0.116820852546 44.394502593 0.0 -0.11842871653 45.2964909452 0.0 -0.11942871653 46.3965503544 0.0 -0.12042871653 47.7530298548 0.0 -0.12142871653 48.8959747456 0.0 -0.12242871653 49.8944248503 0.0 -0.123568503816 50.5502760988 0.0 -0.124568503816 50.9624910885 0.0 -0.125568503816 51.348530794 0.0 -0.126568503816 51.7140457556 0.0 -0.127568503816 52.0684138711 0.0 -0.129055027581 52.6640465008 0.0 -0.130722030504 52.8930761633 0.0 -0.131793271143 52.6771017266 0.0 -0.132793271143 52.9013557638 0.0 -0.1340213974 53.3068009187 0.0 -0.13590905432 53.8101353775 0.0 -0.13690905432 53.3698785414 0.0 -0.13790905432 53.9628426274 0.0 -0.13890905432 54.8930613062 0.0 -0.13991015055 56.0537855157 0.0 -0.14091015055 57.4830538178 0.0 -0.14191015055 59.1481339168 0.0 -0.14291015055 61.0190139991 0.0 -0.14391015055 63.0926871152 0.0 -0.14491015055 65.2731902944 0.0 -0.14591015055 67.4433468903 0.0 -0.146941965989 69.5094800652 0.0 -0.147941965989 71.4105624498 0.0 -0.148941965989 73.1586258412 0.0 -0.149941965989 74.7224569871 0.0 -0.150941965989 76.0746594248 0.0 -0.151941965989 77.184217445 0.0 -0.152941965989 78.0421380658 0.0 -0.153941965989 78.672421446 0.0 -0.154941965989 79.0614876269 0.0 -0.155941965989 79.1876184861 0.0 -0.156941965989 79.2885582683 0.0 -0.157941965989 79.2060770804 0.0 -0.158941965989 79.1140511769 0.0 -0.159941965989 78.9683897062 0.0 -0.160941965989 78.8020706633 0.0 -0.161941965989 78.702489341 0.0 -0.162941965989 78.6872680307 0.0 -0.163941965989 78.7230784823 0.0 -0.164941965989 78.8186018794 0.0 -0.165941965989 78.7956035367 0.0 -0.166941965989 78.9656405933 0.0 -0.167941965989 79.3543725234 0.0 -0.168941965989 79.8221878675 0.0 -0.169941965989 80.2013366394 0.0 -0.170941965989 80.4933771618 0.0 -0.171941965989 80.6627460773 0.0 -0.172941965989 80.6944266546 0.0 -0.173941965989 80.6029708354 0.0 -0.174941965989 80.3840336653 0.0 -0.175941965989 80.0605800974 0.0 -0.176941965989 79.4242979431 0.0 -0.177941965989 78.6539549415 0.0 -0.178941965989 77.8155041995 0.0 -0.179941965989 76.9469433559 0.0 -0.180941965989 76.0931196265 0.0 -0.181941965989 75.3181285657 0.0 -0.182941965989 74.6678144385 0.0 -0.183941965989 74.04119302 0.0 -0.184941965989 76.4325151746 0.0 -0.185941965989 76.071638564 0.0 -0.186941965989 75.5211914445 0.0 -0.187941965989 75.117188024 0.0 -0.188941965989 74.8346709208 0.0 -0.189941965989 74.5734754044 0.0 -0.190941965989 74.3007340042 0.0 -0.192148669497 74.2067623452 0.0 -0.193148669497 73.9064036597 0.0 -0.194148669497 73.81633249 0.0 -0.195587876609 74.0649847862 0.0 -0.197563032802 74.7140712832 0.0 -0.19908070752 74.9540778591 0.0 -0.20008070752 74.9731476875 0.0 -0.20108070752 75.1993082275 0.0 -0.20208070752 75.4554710316 0.0 -0.20308070752 75.7029739535 0.0 -0.20408070752 75.8810657016 0.0 -0.20508070752 76.3191495079 0.0 -0.20608070752 76.6410295228 0.0 -0.20708070752 77.1183619106 0.0 -0.20808070752 77.4690493848 0.0 -0.20908070752 77.9104744906 0.0 -0.21008070752 78.5254344596 0.0 -0.21108070752 79.0810049895 0.0 -0.21208070752 79.6357649411 0.0 -0.21308070752 80.3488185019 0.0 -0.21408070752 80.9993523644 0.0 -0.21508070752 81.7061975237 0.0 -0.21608070752 81.9717583637 0.0 -0.21708070752 83.2264266479 0.0 -0.21808070752 84.3361046574 0.0 -0.21908070752 85.4313111599 0.0 -0.22008070752 86.5553923706 0.0 -0.22108070752 87.7618362441 0.0 -0.22208070752 88.9466295113 0.0 -0.22308070752 90.0350686093 0.0 -0.22408070752 91.0229975917 0.0 -0.22508070752 91.9448111889 0.0 -0.22608070752 92.8132656383 0.0 -0.22708070752 93.6399115487 0.0 -0.22808070752 94.4073208387 0.0 -0.22908070752 95.112084924 0.0 -0.23008070752 95.7563396069 0.0 -0.23108070752 96.3559027133 0.0 -0.23208070752 96.9109664647 0.0 -0.23308070752 97.3878792133 0.0 -0.23408070752 98.0044188829 0.0 -0.23508070752 98.4136369605 0.0 -0.23608070752 98.8338068557 0.0 -0.23708070752 99.2051539224 0.0 -0.23808070752 99.5948874867 0.0 -0.23908070752 99.9779551847 0.0 -0.24008070752 100.33399078 0.0 -0.24108070752 100.660542843 0.0 -0.24208070752 100.972581156 0.0 -0.24308070752 101.272724403 0.0 -0.24408070752 101.561981024 0.0 -0.24508070752 101.843460169 0.0 -0.24608070752 102.115462316 0.0 -0.24708070752 102.374430189 0.0 -0.24808070752 102.621247711 0.0 -0.24908070752 102.846953962 0.0 -0.25008070752 103.059414748 0.0 -0.25108070752 103.253454665 0.0 -0.25215661458 103.485617423 0.0 -0.25315661458 103.65120039 0.0 -0.25415661458 103.795192779 0.0 -0.25515661458 104.073734979 0.0 -0.25615661458 104.375823635 0.0 -0.25715661458 104.68118684 0.0 -0.25815661458 104.974363419 0.0 -0.25915661458 105.208789593 0.0 -0.26015661458 105.027528758 0.0 -0.26115661458 105.625737562 0.0 -0.26215661458 105.290998491 0.0 -0.26315661458 105.065173739 0.0 -0.26415661458 104.888736055 0.0 -0.26515661458 104.605998104 0.0 -0.26615661458 104.222701287 0.0 -0.26715661458 103.778251465 0.0 -0.26815661458 103.296964391 0.0 -0.26915661458 102.737272233 0.0 -0.27015661458 102.144408046 0.0 -0.27115661458 101.550435025 0.0 -0.27215661458 100.977523516 0.0 -0.27315661458 100.451910928 0.0 -0.27415661458 100.027508436 0.0 -0.27515661458 99.7089972642 0.0 -0.27615661458 99.5152260198 0.0 -0.27715661458 99.4328255182 0.0 -0.27815661458 99.4461600634 0.0 -0.27915661458 99.537786944 0.0 -0.28015661458 99.6948911907 0.0 -0.28115661458 99.9145880014 0.0 -0.28215661458 100.199851054 0.0 -0.28315661458 100.546402528 0.0 -0.28415661458 100.970852992 0.0 -0.28515661458 101.39161229 0.0 -0.286704419242 102.180642962 0.0 -0.287704419242 102.805022878 0.0 -0.288704419242 103.417714043 0.0 -0.289704419242 104.011853357 0.0 -0.290704419242 104.591563047 0.0 -0.291704419242 105.194130126 0.0 -0.292704419242 105.781003738 0.0 -0.293704419242 106.362547029 0.0 -0.294704419242 106.927233391 0.0 -0.295704419242 107.510884773 0.0 -0.296704419242 108.085641599 0.0 -0.297704419242 108.646159315 0.0 -0.298704419242 109.199119605 0.0 -0.299704419242 109.729159497 0.0 -0.300704419242 110.279315939 0.0 -0.301704419242 110.792265441 0.0 -0.302704419242 111.342161134 0.0 -0.303704419242 112.045465434 0.0 -0.304704419242 112.572175251 0.0 -0.305704419242 113.034677745 0.0 -0.306704419242 113.562014128 0.0 -0.307704419242 114.213382348 0.0 -0.308704419242 115.609827732 0.0 -0.309704419242 116.444298757 0.0 -0.310704419242 117.148704406 0.0 -0.311704419242 117.819431392 0.0 -0.312704419242 118.444397329 0.0 -0.313704419242 119.045127231 0.0 -0.314704419242 120.727621199 0.0 -0.315704419242 121.649623906 0.0 -0.316704419242 122.332458144 0.0 -0.317704419242 122.937883767 0.0 -0.318704419242 123.332982774 0.0 -0.319704419242 123.663226628 0.0 -0.320704419242 123.909286626 0.0 -0.321704419242 124.065436628 0.0 -0.322704419242 124.44980015 0.0 -0.323704419242 124.96545812 0.0 -0.324704419242 125.911643151 0.0 -0.325704419242 126.285586667 0.0 -0.326704419242 126.455068882 0.0 -0.327704419242 126.694363927 0.0 -0.328704419242 127.085026387 0.0 -0.329704419242 127.571243101 0.0 -0.330704419242 128.098509506 0.0 -0.331704419242 128.633214002 0.0 -0.332704419242 129.158566572 0.0 -0.333704419242 129.651420424 0.0 -0.334704419242 130.226214777 0.0 -0.335704419242 130.684272479 0.0 -0.336704419242 131.112605045 0.0 -0.337704419242 131.491233616 0.0 -0.338704419242 131.989090827 0.0 -0.339704419242 132.471602772 0.0 -0.340704419242 132.934045712 0.0 -0.341704419242 133.444158418 0.0 -0.342704419242 134.028035453 0.0 -0.343704419242 134.518613447 0.0 -0.344704419242 135.0210565 0.0 -0.345704419242 135.558855796 0.0 -0.346704419242 136.192115217 0.0 -0.347704419242 136.744197695 0.0 -0.348704419242 137.333672306 0.0 -0.349704419242 137.906125047 0.0 -0.350704419242 138.430901181 0.0 -0.351704419242 138.988476628 0.0 -0.352704419242 140.413221509 0.0 -0.353704419242 141.442753645 0.0 -0.354704419242 142.280516731 0.0 -0.355704419242 143.091043353 0.0 -0.356704419242 143.860220843 0.0 -0.357704419242 144.527724418 0.0 -0.358704419242 145.084105191 0.0 -0.359704419242 145.578779414 0.0 -0.360704419242 145.989851508 0.0 -0.361704419242 146.413304713 0.0 -0.362704419242 146.776761469 0.0 -0.363704419242 147.045379491 0.0 -0.364704419242 147.269358191 0.0 -0.365704419242 147.65608855 0.0 -0.366704419242 148.249337193 0.0 -0.367704419242 149.31232461 0.0 -0.368704419242 150.31064575 0.0 -0.369704419242 151.410647589 0.0 -0.370704419242 148.969559223 0.0 -0.371704419242 152.277897411 0.0 -0.372704419242 149.332361431 0.0 -0.373704419242 153.105265308 0.0 -0.374704419242 149.476518898 0.0 -0.375704419242 153.774671899 0.0 -0.376704419242 146.5006218 0.0 -0.377704419242 153.919115387 0.0 -0.378704419242 143.399639861 0.0 -0.379704419242 153.363493279 0.0 -0.380704419242 149.51014417 0.0 -0.381704419242 153.771879313 0.0 -0.382704419242 148.136324016 0.0 -0.383704419242 152.677945331 0.0 -0.384704419242 145.50976971 0.0 -0.385704419242 150.761253352 0.0 -0.386704419242 142.979586639 0.0 -0.387704419242 150.34517684 0.0 -0.388704419242 142.417180819 0.0 -0.389704419242 149.657048602 0.0 -0.390704419242 133.813937709 0.0 -0.391704419242 149.188478306 0.0 -0.392704419242 132.27872596 0.0 -0.393704419242 149.661367865 0.0 -0.394704419242 153.36526163 0.0 -0.395704419242 156.328183019 0.0 -0.396704419242 157.555594488 0.0 -0.397704419242 157.764253789 0.0 -0.398704419242 157.600948085 0.0 -0.399704419242 157.331270877 0.0 -0.400704419242 157.359331443 0.0 -0.401704419242 157.730442011 0.0 -0.402704419242 158.535513403 0.0 -0.403704419242 159.568482783 0.0 -0.404704419242 161.32135991 0.0 -0.405704419242 166.685870057 0.0 -0.406704419242 168.530107725 0.0 -0.407704419242 169.689527193 0.0 -0.408704419242 172.815661793 0.0 -0.409704419242 174.683528079 0.0 -0.410704419242 175.802039834 0.0 -0.411704419242 176.679212228 0.0 -0.412704419242 177.237091224 0.0 -0.413704419242 177.643453807 0.0 -0.414704419242 178.090715334 0.0 -0.415704419242 178.976123568 0.0 -0.416704419242 180.329617826 0.0 -0.417704419242 180.953287675 0.0 -0.418704419242 181.630172862 0.0 -0.419704419242 182.350500609 0.0 -0.420704419242 182.744603208 0.0 -0.421704419242 183.192369499 0.0 -0.422704419242 182.926035199 0.0 -0.423704419242 178.333269931 0.0 -0.424704419242 184.123815781 0.0 -0.425704419242 178.387526 0.0 -0.426704419242 185.337486166 0.0 -0.427704419242 178.539951131 0.0 -0.428704419242 177.761041391 0.0 -0.429704419242 186.666071552 0.0 -0.430704419242 176.42071626 0.0 -0.431704419242 188.223990506 0.0 -0.432704419242 175.865247097 0.0 -0.433704419242 177.532423796 0.0 -0.434704419242 188.990738526 0.0 -0.435704419242 188.989089054 0.0 -0.436704419242 188.098268784 0.0 -0.437704419242 187.021344487 0.0 -0.438704419242 186.389127806 0.0 -0.439704419242 186.244781401 0.0 -0.440704419242 185.999374731 0.0 -0.441704419242 185.911173312 0.0 -0.442704419242 186.112935315 0.0 -0.443704419242 186.691543284 0.0 -0.444704419242 187.602219126 0.0 -0.445704419242 188.907810458 0.0 -0.446704419242 190.401564563 0.0 -0.447704419242 191.996562443 0.0 -0.448704419242 193.752694778 0.0 -0.449704419242 195.536072929 0.0 -0.450704419242 197.363808651 0.0 -0.451704419242 199.119724971 0.0 -0.452704419242 200.806606335 0.0 -0.453704419242 202.393822848 0.0 -0.454704419242 194.952578061 0.0 -0.455704419242 203.813466586 0.0 -0.456704419242 196.039920456 0.0 -0.457704419242 205.939684373 0.0 -0.458704419242 197.629507379 0.0 -0.459704419242 211.173777738 0.0 -0.460704419242 196.739679536 0.0 -0.461704419242 197.978634404 0.0 -0.462704419242 212.916841321 0.0 -0.463704419242 196.907371406 0.0 -0.464704419242 214.7742438 0.0 -0.465704419242 196.817585128 0.0 -0.466704419242 199.440215331 0.0 -0.467704419242 214.189990655 0.0 -0.468704419242 218.282244947 0.0 -0.469704419242 220.032732542 0.0 -0.470704419242 220.383304754 0.0 -0.471704419242 221.121832207 0.0 -0.472704419242 220.758409926 0.0 -0.473704419242 219.493837914 0.0 -0.474704419242 216.201272846 0.0 -0.475704419242 212.449707351 0.0 -0.476704419242 209.972617504 0.0 -0.477704419242 211.405825007 0.0 -0.478704419242 210.832167488 0.0 -0.479704419242 210.554933624 0.0 -0.480704419242 206.635126684 0.0 -0.481704419242 209.603412398 0.0 -0.482704419242 207.082641609 0.0 -0.483704419242 211.429156084 0.0 -0.484704419242 200.65656218 0.0 -0.485704419242 215.211851936 0.0 -0.486704419242 197.379507448 0.0 -0.487704419242 204.776087449 0.0 -0.488704419242 218.724470731 0.0 -0.489704419242 222.374350679 0.0 -0.490704419242 223.346745309 0.0 -0.491704419242 222.505408919 0.0 -0.492704419242 221.395429004 0.0 -0.493704419242 219.912871463 0.0 -0.494704419242 218.742217603 0.0 -0.495704419242 217.984985735 0.0 -0.496704419242 215.273437884 0.0 -0.497704419242 214.579185533 0.0 -0.498704419242 218.390317462 0.0 -0.499704419242 207.78305615 0.0 -0.500704419242 216.873622693 0.0 -0.501704419242 218.872673186 0.0 -0.502704419242 220.795287219 0.0 -0.503704419242 221.890785631 0.0 -0.504704419242 230.608325055 0.0 -0.505704419242 225.351899853 0.0 -0.506704419242 232.921222003 0.0 -0.507704419242 234.653009424 0.0 -0.508704419242 235.996937698 0.0 -0.509704419242 236.570290079 0.0 -0.510704419242 236.740689911 0.0 -0.511704419242 237.333446436 0.0 -0.512704419242 237.798266479 0.0 -0.513704419242 237.946020872 0.0 -0.514704419242 238.051925289 0.0 -0.515704419242 232.812098944 0.0 -0.516704419242 237.777794453 0.0 -0.517704419242 223.976424395 0.0 -0.518704419242 237.773241569 0.0 -0.519704419242 225.917477153 0.0 -0.520704419242 225.784066911 0.0 -0.521704419242 244.812248627 0.0 -0.522704419242 228.302868943 0.0 -0.523704419242 225.87470431 0.0 -0.524704419242 250.444853657 0.0 -0.525704419242 255.845234331 0.0 -0.526704419242 255.634396332 0.0 -0.527704419242 253.416599087 0.0 -0.528704419242 249.794856052 0.0 -0.529704419242 246.489166095 0.0 -0.530704419242 237.361384654 0.0 -0.531704419242 240.849173978 0.0 -0.532704419242 239.817351063 0.0 -0.533704419242 238.748036657 0.0 -0.534704419242 238.206787071 0.0 -0.535704419242 238.045898065 0.0 -0.536704419242 238.160233217 0.0 -0.537704419242 238.533748411 0.0 -0.538704419242 239.121129562 0.0 -0.539704419242 240.034946506 0.0 -0.540704419242 240.848055157 0.0 -0.541704419242 240.888627181 0.0 -0.542704419242 239.610625156 0.0 -0.543704419242 238.435963376 0.0 -0.544704419242 236.538043901 0.0 -0.545704419242 241.721836671 0.0 -0.546704419242 241.635214146 0.0 -0.547704419242 240.826146028 0.0 -0.548704419242 239.869909474 0.0 -0.549704419242 244.065043054 0.0 -0.550704419242 242.475412897 0.0 -0.551704419242 240.88127102 0.0 -0.552704419242 239.392753405 0.0 -0.553704419242 238.102506815 0.0 -0.554704419242 236.771850414 0.0 -0.555704419242 236.07552024 0.0 -0.556704419242 243.492519184 0.0 -0.557704419242 233.723093544 0.0 -0.558704419242 244.180688298 0.0 -0.559704419242 244.145464112 0.0 -0.560704419242 243.459773176 0.0 -0.561704419242 252.489030414 0.0 -0.562704419242 246.039196907 0.0 -0.563704419242 244.327736031 0.0 -0.564704419242 252.832560297 0.0 -0.565704419242 243.925501479 0.0 -0.566704419242 243.031512987 0.0 -0.567704419242 252.828463372 0.0 -0.568704419242 243.894637141 0.0 -0.569704419242 242.73690067 0.0 -0.570704419242 242.686095006 0.0 -0.571704419242 254.739856966 0.0 -0.572704419242 257.446205074 0.0 -0.573704419242 258.959343469 0.0 -0.574704419242 259.362846508 0.0 -0.575704419242 260.108696031 0.0 -0.576704419242 260.148943588 0.0 -0.577704419242 260.424542335 0.0 -0.578704419242 267.725405432 0.0 -0.579704419242 262.063283867 0.0 -0.580704419242 267.215322407 0.0 -0.581704419242 283.578773478 0.0 -0.582704419242 274.622627201 0.0 -0.583704419242 274.7648826 0.0 -0.584704419242 275.611336614 0.0 -0.585704419242 276.382036883 0.0 -0.586704419242 287.156870503 0.0 -0.587704419242 278.548158598 0.0 -0.588704419242 288.318436609 0.0 -0.589704419242 288.794190008 0.0 -0.590704419242 295.301500701 0.0 -0.591704419242 278.632368193 0.0 -0.592704419242 292.022191961 0.0 -0.593704419242 281.442398103 0.0 -0.594704419242 291.18989639 0.0 -0.595704419242 278.600613711 0.0 -0.596704419242 288.248529214 0.0 -0.597704419242 276.493486613 0.0 -0.598704419242 286.21527705 0.0 -0.599704419242 274.874623977 0.0 -0.600704419242 285.378585578 0.0 -0.601704419242 273.895259477 0.0 -0.602704419242 284.876977005 0.0 -0.603704419242 273.41933823 0.0 -0.604704419242 284.725706824 0.0 -0.605704419242 273.284777091 0.0 -0.606704419242 284.906109516 0.0 -0.607704419242 272.994078825 0.0 -0.608704419242 284.718800902 0.0 -0.609704419242 272.546969437 0.0 -0.610704419242 284.466291165 0.0 -0.611704419242 272.616376275 0.0 -0.612704419242 284.603773234 0.0 -0.613704419242 285.455993637 0.0 -0.614704419242 273.387035248 0.0 -0.615704419242 284.574020667 0.0 -0.616704419242 285.096335787 0.0 -0.617704419242 273.634336273 0.0 -0.618704419242 284.713640342 0.0 -0.619704419242 285.346516789 0.0 -0.620704419242 285.952741571 0.0 -0.621704419242 274.898812113 0.0 -0.622704419242 286.20886333 0.0 -0.623704419242 287.53826862 0.0 -0.624704419242 275.578234275 0.0 -0.625704419242 287.862347807 0.0 -0.626704419242 290.326527153 0.0 -0.627704419242 291.978973583 0.0 -0.628704419242 280.911857383 0.0 -0.629704419242 293.400162878 0.0 -0.630704419242 296.353827916 0.0 -0.631704419242 297.641930154 0.0 -0.632704419242 298.904993479 0.0 -0.633704419242 287.437721445 0.0 -0.634704419242 299.216210343 0.0 -0.635704419242 301.43069009 0.0 -0.636704419242 290.660035882 0.0 -0.637704419242 301.250192207 0.0 -0.638704419242 303.2884767 0.0 -0.639704419242 290.471547303 0.0 -0.640704419242 301.494350912 0.0 -0.641704419242 302.332313632 0.0 -0.642704419242 304.36626225 0.0 -0.643704419242 303.789924975 0.0 -0.644704419242 301.787517166 0.0 -0.645704419242 299.205626214 0.0 -0.646704419242 297.225412337 0.0 -0.647704419242 299.467246898 0.0 -0.648704419242 300.801057168 0.0 -0.649704419242 300.152373033 0.0 -0.650704419242 296.102127083 0.0 -0.651704419242 292.432566911 0.0 -0.652704419242 295.10860229 0.0 -0.653704419242 293.921879261 0.0 -0.654704419242 296.544338993 0.0 -0.655704419242 296.110405596 0.0 -0.656704419242 295.465390484 0.0 -0.657704419242 301.166636732 0.0 -0.658704419242 301.80336568 0.0 -0.659704419242 301.552881028 0.0 -0.660704419242 301.054631117 0.0 -0.661704419242 300.541420753 0.0 -0.662704419242 300.145168732 0.0 -0.663704419242 299.774908097 0.0 -0.664704419242 299.609063856 0.0 -0.665704419242 299.74623757 0.0 -0.666704419242 300.211560061 0.0 -0.667704419242 300.816970395 0.0 -0.668704419242 301.84284477 0.0 -0.669704419242 302.809957164 0.0 -0.670704419242 303.66345981 0.0 -0.671704419242 304.585584913 0.0 -0.672704419242 305.418036772 0.0 -0.673704419242 306.15779031 0.0 -0.674704419242 307.190780508 0.0 -0.675704419242 308.138138176 0.0 -0.676704419242 308.748399994 0.0 -0.677704419242 309.401791837 0.0 -0.678704419242 310.753199556 0.0 -0.679704419242 312.057240313 0.0 -0.680704419242 313.151065345 0.0 -0.681704419242 314.215946489 0.0 -0.682704419242 315.394678813 0.0 -0.683704419242 316.765921991 0.0 -0.684704419242 317.781588857 0.0 -0.685704419242 318.522406811 0.0 -0.686704419242 319.034489582 0.0 -0.687704419242 319.86614386 0.0 -0.688704419242 320.262436535 0.0 -0.689704419242 320.592704727 0.0 -0.690704419242 321.009994706 0.0 -0.691704419242 321.316661579 0.0 -0.692704419242 321.743284028 0.0 -0.693704419242 322.153684803 0.0 -0.694704419242 323.482378698 0.0 -0.695704419242 324.394561109 0.0 -0.696704419242 325.257781361 0.0 -0.697704419242 326.019440979 0.0 -0.698704419242 330.589889148 0.0 -0.699704419242 330.890937524 0.0 -0.700840289635 328.550206918 0.0 -0.701840289635 326.34227782 0.0 -0.702840289635 324.425284524 0.0 -0.703840289635 323.30746368 0.0 -0.705005653771 321.844809793 0.0 -0.706005653771 318.242081361 0.0 -0.707005653771 317.248812809 0.0 -0.708005653771 326.242388734 0.0 -0.709005653771 315.660412742 0.0 -0.710005653771 325.174903875 0.0 -0.711005653771 324.448979905 0.0 -0.712005653771 321.513189301 0.0 -0.713005653771 324.542651389 0.0 -0.714058670857 330.185328144 0.0 -0.715058670857 329.302470218 0.0 -0.716058670857 327.643305908 0.0 -0.717058670857 325.702901499 0.0 -0.718058670857 323.624995427 0.0 -0.719058670857 321.68060484 0.0 -0.720058670857 320.384198557 0.0 -0.721058670857 319.911960714 0.0 -0.722058670857 319.80780197 0.0 -0.723058670857 320.242325827 0.0 -0.724058670857 320.79227649 0.0 -0.725058670857 321.915510201 0.0 -0.726058670857 322.990145081 0.0 -0.727058670857 324.789073819 0.0 -0.728058670857 326.474153301 0.0 -0.729058670857 328.050477132 0.0 -0.730872738781 329.068262484 0.0 -0.731872738781 331.230264296 0.0 -0.732872738781 332.61372547 0.0 -0.733872738781 333.605671695 0.0 -0.734872738781 334.530674567 0.0 -0.735872738781 335.31927561 0.0 -0.736872738781 335.917414649 0.0 -0.738330297061 336.187927673 0.0 -0.739330297061 337.026053765 0.0 -0.74085092521 337.085620699 0.0 -0.74185092521 337.625890785 0.0 -0.742876495023 337.585192525 0.0 -0.743876495023 337.513773922 0.0 -0.744876495023 337.249082555 0.0 -0.745876495023 337.718668782 0.0 -0.746876495023 337.70264074 0.0 -0.747876495023 337.768722137 0.0 -0.748876495023 337.882174742 0.0 -0.749876495023 337.93931974 0.0 -0.751150678164 337.956886965 0.0 -0.752150678164 338.354067962 0.0 -0.753150678164 338.449220014 0.0 -0.754150678164 338.547836456 0.0 -0.755150678164 337.010646779 0.0 -0.756150678164 335.645447284 0.0 -0.757150678164 336.357316555 0.0 -0.758150678164 338.61298483 0.0 -0.759150678164 333.601179121 0.0 -0.760150678164 338.511865064 0.0 -0.761150678164 331.941795337 0.0 -0.762150678164 338.302065201 0.0 -0.763150678164 338.753018843 0.0 -0.764812333239 338.173960414 0.0 -0.765865956027 338.150300299 0.0 -0.766865956027 337.678405889 0.0 -0.767865956027 337.095514662 0.0 -0.768865956027 336.475968202 0.0 -0.770617238573 335.953284161 0.0 -0.771617238573 336.110533231 0.0 -0.772617238573 335.727596723 0.0 -0.774049999783 335.732621078 0.0 -0.775049999783 335.573397246 0.0 -0.776049999783 335.188220853 0.0 -0.77756620937 334.494212466 0.0 -0.77856620937 334.425490769 0.0 -0.77956620937 334.194839296 0.0 -0.78056620937 334.12044424 0.0 -0.78156620937 334.224575652 0.0 -0.78256620937 334.383375441 0.0 -0.78356620937 334.620867683 0.0 -0.78456620937 334.58159381 0.0 -0.78556620937 334.857328624 0.0 -0.78656620937 335.329720384 0.0 -0.78756620937 335.85614876 0.0 -0.78856620937 336.447190122 0.0 -0.78956620937 336.341162408 0.0 -0.79056620937 336.05076623 0.0 -0.79156620937 335.877385601 0.0 -0.79256620937 335.570684042 0.0 -0.79356620937 338.701100655 0.0 -0.79456620937 335.583157256 0.0 -0.79556620937 334.805970017 0.0 -0.79656620937 338.741863438 0.0 -0.79756620937 334.482053837 0.0 -0.79856620937 338.60161029 0.0 -0.79956620937 331.592929223 0.0 -0.80056620937 338.235839785 0.0 -0.80156620937 330.724041466 0.0 -0.80256620937 338.033214511 0.0 -0.80356620937 330.051837048 0.0 -0.804576892917 338.535593413 0.0 -0.805689842216 330.52692293 0.0 -0.806689842216 339.228567054 0.0 -0.808009951623 337.902508909 0.0 -0.809768983878 335.34395974 0.0 -0.811611054923 336.42528203 0.0 -0.812611054923 333.872636029 0.0 -0.813932519938 335.567451522 0.0 -0.814932519938 332.665080035 0.0 -0.815932519938 335.171021617 0.0 -0.816932519938 332.096839813 0.0 -0.817932519938 331.73287328 0.0 -0.818932519938 334.786976741 0.0 -0.819932519938 332.010783176 0.0 -0.820932519938 332.007227912 0.0 -0.821932519938 335.501792012 0.0 -0.822932519938 332.568325123 0.0 -0.825385447543 332.252855994 0.0 -0.826611911246 333.466515874 0.0 -0.827611911246 335.737427862 0.0 -0.828611911246 337.111910341 0.0 -0.829611911246 336.45259721 0.0 -0.830611911246 336.118998134 0.0 -0.832336963719 334.8156672 0.0 -0.833336963719 335.787722759 0.0 -0.834336963719 333.484541738 0.0 -0.835336963719 335.099734351 0.0 -0.836336963719 332.368590506 0.0 -0.837684090032 334.342837952 0.0 -0.838684090032 331.930858599 0.0 -0.839684090032 335.295067505 0.0 -0.841016159099 334.578355782 0.0 -0.842472974019 334.207320466 0.0 -0.843845758613 334.063294467 0.0 -0.845248736287 333.818619557 0.0 -0.846248736287 330.342752244 0.0 -0.847248736287 335.696844895 0.0 -0.848248736287 334.818853498 0.0 -0.849345166 333.760122562 0.0 -0.850639716884 332.711187612 0.0 -0.852250746195 331.830714446 0.0 -0.853525482759 331.074361728 0.0 -0.8554695621 330.260724067 0.0 -0.858330119922 327.002089954 0.0 -0.86225900174 327.860723221 0.0 -0.865032122697 320.726098207 0.0 -0.868755061947 324.010956941 0.0 -0.875569574097 320.612838915 0.0 -0.878976830162 321.722106691 0.0 -0.880680458408 321.757145615 0.0 -0.88170880673 319.62513245 0.0 -0.886337970559 316.389026509 0.0 -0.888652552422 314.989271054 0.0 -0.890099293531 314.857460254 0.0 -0.891099293531 314.924634719 0.0 -0.892099293531 314.946081083 0.0 -0.894698624771 314.114159531 0.0 -0.895998290362 315.720768592 0.0 -0.89728548488 316.885179212 0.0 -0.898521918515 317.333829832 0.0 -0.899675397995 318.38334479 0.0 -0.900891367847 319.259406452 0.0 -0.902008446816 320.089210948 0.0 -0.903160344908 320.646896852 0.0 -0.904160344908 318.300499096 0.0 -0.905397452868 318.012843606 0.0 -0.906472308067 317.97753931 0.0 -0.907650979175 322.499976288 0.0 -0.908787770253 318.44553352 0.0 -0.90997369484 318.450829049 0.0 -0.91097369484 317.319388141 0.0 -0.912355519501 316.19613977 0.0 -0.913551763358 322.377290173 0.0 -0.91487569094 315.394589678 0.0 -0.916178605168 321.001371701 0.0 -0.917536280146 313.872221305 0.0 -0.918912259993 312.808515842 0.0 -0.920321948116 318.937930325 0.0 -0.92175745847 318.029888357 0.0 -0.923180352656 316.448887955 0.0 -0.924180352656 314.792104279 0.0 -0.925180352656 313.17350549 0.0 -0.927021648454 311.521011896 0.0 -0.928502143348 310.262291673 0.0 -0.929502143348 312.068762404 0.0 -0.930502143348 310.249517624 0.0 -0.931502143348 308.531814882 0.0 -0.932502143348 307.200327738 0.0 -0.933502143348 306.197847692 0.0 -0.93501798055 305.10304152 0.0 -0.936593246028 304.130685876 0.0 -0.937791368108 303.382672927 0.0 -0.938846565691 302.587144726 0.0 -0.939846565691 301.589679485 0.0 -0.940846565691 301.056173199 0.0 -0.941846565691 297.307552318 0.0 -0.942846565691 293.731732738 0.0 -0.943846565691 290.127257684 0.0 -0.946070499473 286.885751105 0.0 -0.947361999174 284.025601225 0.0 -0.948689222171 284.305513063 0.0 -0.949689222171 282.68028514 0.0 -0.950689222171 279.970945527 0.0 -0.951689222171 277.868194361 0.0 -0.952689222171 273.900827409 0.0 -0.953689222171 287.142704337 0.0 -0.954689222171 283.493610991 0.0 -0.955689222171 280.535254867 0.0 -0.956689222171 277.156003869 0.0 -0.957689222171 274.45841802 0.0 -0.958689222171 272.000676745 0.0 -0.959689222171 279.196673845 0.0 -0.960689222171 279.963409112 0.0 -0.961689222171 279.443103094 0.0 -0.962689222171 279.030397881 0.0 -0.963689222171 278.845114987 0.0 -0.964689222171 278.874316718 0.0 -0.965689222171 279.307609515 0.0 -0.966689222171 280.186052791 0.0 -0.967689222171 281.30856878 0.0 -0.968689222171 282.803204719 0.0 -0.969849797258 283.489630037 0.0 -0.971260140804 284.457246792 0.0 -0.972481517387 286.35036076 0.0 -0.973536771729 287.275266698 0.0 -0.974536771729 288.532356626 0.0 -0.975536771729 289.691006326 0.0 -0.976536771729 290.800022063 0.0 -0.977536771729 291.721454823 0.0 -0.978536771729 293.661053536 0.0 -0.979536771729 293.955373189 0.0 -0.980536771729 293.729600515 0.0 -0.981536771729 292.978390015 0.0 -0.982536771729 291.506580804 0.0 -0.983536771729 291.278642639 0.0 -0.984536771729 289.557196034 0.0 -0.985536771729 288.242334003 0.0 -0.986536771729 288.554498101 0.0 -0.987536771729 287.623467639 0.0 -0.988536771729 285.0131898 0.0 -0.989536771729 285.563437314 0.0 -0.990536771729 284.660483972 0.0 -0.991536771729 283.701234036 0.0 -0.992536771729 282.614603842 0.0 -0.993536771729 281.466771781 0.0 -0.994536771729 280.09188099 0.0 -0.995536771729 278.643442389 0.0 -0.996536771729 277.168811693 0.0 -0.997536771729 275.562980333 0.0 -0.998536771729 273.993467329 0.0 -0.999536771729 272.269717586 0.0 -1.00053677173 270.602923632 0.0 -1.00153677173 269.210313111 0.0 -1.00253677173 267.70562361 0.0 -1.00353677173 263.659766279 0.0 -1.00453677173 264.210567167 0.0 -1.00553677173 263.471335139 0.0 -1.00653677173 258.579366211 0.0 -1.00753677173 259.307600602 0.0 -1.00853677173 257.24950642 0.0 -1.00953677173 255.365843411 0.0 -1.01053677173 253.181486618 0.0 -1.01153677173 251.395154399 0.0 -1.01253677173 249.637906686 0.0 -1.01353677173 248.792469444 0.0 -1.01453677173 247.927601541 0.0 -1.01553677173 247.181861052 0.0 -1.01653677173 246.640111815 0.0 -1.01753677173 246.061194751 0.0 -1.01854039085 245.623359789 0.0 -1.01954039085 245.317335883 0.0 -1.02054039085 245.841506196 0.0 -1.02154039085 245.541760092 0.0 -1.02254039085 244.61295359 0.0 -1.02354039085 243.676907686 0.0 -1.02454039085 242.653029437 0.0 -1.02554039085 241.684507845 0.0 -1.02654039085 240.686632208 0.0 -1.02754039085 239.782732905 0.0 -1.02854039085 238.931974721 0.0 -1.02954039085 238.151100825 0.0 -1.03054039085 236.81798012 0.0 -1.03154039085 236.295100709 0.0 -1.03254039085 235.887025541 0.0 -1.03354039085 235.284640925 0.0 -1.03454039085 234.718016337 0.0 -1.03554039085 234.326767155 0.0 -1.03654039085 233.498900549 0.0 -1.03754039085 232.80549442 0.0 -1.03854039085 232.211336796 0.0 -1.03954039085 231.417580315 0.0 -1.04054039085 232.253885436 0.0 -1.04154039085 230.650370124 0.0 -1.04254039085 228.724842624 0.0 -1.04354039085 226.661156725 0.0 -1.04454039085 227.693416803 0.0 -1.04554039085 226.090490884 0.0 -1.04654039085 226.804343817 0.0 -1.04754039085 224.096760363 0.0 -1.04854039085 221.802315503 0.0 -1.04954039085 223.530179816 0.0 -1.05054039085 216.018076236 0.0 -1.05154039085 217.245529007 0.0 -1.05254039085 220.455304416 0.0 -1.05354039085 212.263355906 0.0 -1.05454039085 214.341532474 0.0 -1.05554039085 218.741258783 0.0 -1.05654039085 219.790434417 0.0 -1.05754039085 219.578327458 0.0 -1.05854039085 219.387150263 0.0 -1.05954039085 219.062274966 0.0 -1.06054039085 218.457183985 0.0 -1.06154039085 217.692377929 0.0 -1.06254039085 216.855495793 0.0 -1.06354039085 215.985993562 0.0 -1.06454039085 215.138555133 0.0 -1.06554039085 214.323677065 0.0 -1.06654039085 213.591924052 0.0 -1.06754039085 212.979155601 0.0 -1.06854039085 208.799496462 0.0 -1.06954039085 211.338426939 0.0 -1.07054039085 207.28769327 0.0 -1.07154039085 210.821365636 0.0 -1.07254039085 206.564091612 0.0 -1.07354039085 210.55336625 0.0 -1.07454039085 205.802643649 0.0 -1.07554039085 209.81395366 0.0 -1.07654039085 204.500469016 0.0 -1.07754039085 208.599494948 0.0 -1.07854039085 207.733488839 0.0 -1.07954039085 206.9991847 0.0 -1.08054039085 206.18435804 0.0 -1.08154039085 205.111638661 0.0 -1.08254039085 203.279298788 0.0 -1.08354039085 201.283603013 0.0 -1.08454039085 199.241871106 0.0 -1.08554039085 197.406301536 0.0 -1.08654039085 195.907193011 0.0 -1.08754039085 194.749132117 0.0 -1.08854039085 193.907713803 0.0 -1.08954039085 193.23024971 0.0 -1.09054039085 192.559843812 0.0 -1.09154039085 192.38747282 0.0 -1.09254039085 191.952898236 0.0 -1.09354039085 191.538528433 0.0 -1.09454039085 190.999197508 0.0 -1.09554039085 190.441677261 0.0 -1.09654039085 189.762716674 0.0 -1.09754039085 188.707026566 0.0 -1.09854039085 187.474020047 0.0 -1.09954039085 186.562328658 0.0 -1.10054039085 185.48042699 0.0 -1.10154039085 184.385784516 0.0 -1.10254039085 183.42462771 0.0 -1.10354039085 182.417097957 0.0 -1.10454039085 181.394287375 0.0 -1.10554039085 180.359868341 0.0 -1.10654039085 179.323644639 0.0 -1.10754039085 178.224674115 0.0 -1.10854039085 177.219513243 0.0 -1.10954039085 176.199841145 0.0 -1.11054039085 175.205055121 0.0 -1.11154039085 174.239939586 0.0 -1.11254039085 173.240413196 0.0 -1.11354039085 172.420346396 0.0 -1.11454039085 171.481368147 0.0 -1.11554039085 170.47447127 0.0 -1.11654039085 169.752028549 0.0 -1.11754039085 168.885698649 0.0 -1.11854039085 167.916517888 0.0 -1.11954039085 167.085476059 0.0 -1.12054039085 166.307918361 0.0 -1.12154039085 165.344926574 0.0 -1.12254039085 164.229380876 0.0 -1.12354039085 162.780206591 0.0 -1.12454039085 161.390942708 0.0 -1.12554039085 159.921593629 0.0 -1.12654039085 158.469986143 0.0 -1.12754039085 157.0904505 0.0 -1.12854039085 155.726095633 0.0 -1.12954039085 154.45226258 0.0 -1.13054039085 153.216368535 0.0 -1.13154039085 152.344149077 0.0 -1.13254039085 151.016123268 0.0 -1.13354039085 149.931494977 0.0 -1.13454039085 149.325119468 0.0 -1.13554039085 148.533221636 0.0 -1.13654039085 148.692135709 0.0 -1.13754039085 147.431859088 0.0 -1.13854039085 146.582396959 0.0 -1.13954039085 145.439863761 0.0 -1.14054039085 144.409757394 0.0 -1.14154039085 143.360902958 0.0 -1.14254039085 139.249155237 0.0 -1.14354039085 135.252375354 0.0 -1.14454039085 126.320674611 0.0 -1.14554039085 123.634028617 0.0 -1.14654039085 122.179215091 0.0 -1.14754039085 122.232359671 0.0 -1.14854039085 122.86478005 0.0 -1.14954039085 129.982565429 0.0 -1.15054039085 132.429447766 0.0 -1.15154039085 134.599994087 0.0 -1.15254039085 137.028427683 0.0 -1.15354039085 139.652659953 0.0 -1.15454039085 140.28974645 0.0 -1.15554039085 139.933657915 0.0 -1.15654039085 138.054139585 0.0 -1.15754039085 136.285924791 0.0 -1.15854039085 135.345472554 0.0 -1.15954039085 134.069198057 0.0 -1.16054039085 132.989367823 0.0 -1.16154039085 132.431796919 0.0 -1.16254039085 131.827378596 0.0 -1.16354039085 132.06105721 0.0 -1.16454039085 132.214407098 0.0 -1.16554039085 132.386224226 0.0 -1.16654039085 132.409183383 0.0 -1.16754039085 132.355114125 0.0 -1.16854039085 132.030678848 0.0 -1.16954039085 131.507466918 0.0 -1.17054039085 130.741512095 0.0 -1.17154039085 129.904778065 0.0 -1.17254039085 129.642897537 0.0 -1.17354039085 128.082585149 0.0 -1.17454039085 125.328676562 0.0 -1.17554039085 122.698900404 0.0 -1.17654039085 119.353284904 0.0 -1.17754039085 116.546634711 0.0 -1.17854039085 113.68400552 0.0 -1.17954039085 111.378865603 0.0 -1.18054039085 108.731727119 0.0 -1.18154039085 108.614131069 0.0 -1.18254039085 107.122183486 0.0 -1.18354039085 105.477566748 0.0 -1.18454039085 103.436002235 0.0 -1.18554039085 100.981399601 0.0 -1.18654039085 98.5559858554 0.0 -1.18754039085 95.4032618116 0.0 -1.18854039085 93.0325720873 0.0 -1.18954039085 91.244712978 0.0 -1.19054039085 89.4212684751 0.0 -1.19154039085 87.620256833 0.0 -1.19254039085 85.9718970562 0.0 -1.19354039085 84.6827341328 0.0 -1.19454039085 83.5851273661 0.0 -1.19554039085 82.8022510525 0.0 -1.19654039085 82.3068205205 0.0 -1.19754039085 81.3790458798 0.0 -1.19854039085 78.9145931751 0.0 -1.19954039085 77.0433952398 0.0 -1.20054039085 75.26424315 0.0 -1.20154039085 74.2170799524 0.0 -1.20254039085 74.2887610319 0.0 -1.20354039085 75.0975628556 0.0 -1.20454039085 75.6962087172 0.0 -1.20554039085 76.5554220351 0.0 -1.20654039085 76.4037344156 0.0 -1.20754039085 76.2200607028 0.0 -1.20854039085 76.2054605694 0.0 -1.20954039085 75.7972742186 0.0 -1.21054039085 75.1173760162 0.0 -1.21154039085 74.2901959002 0.0 -1.21254039085 73.4110432754 0.0 -1.21354039085 72.4708588822 0.0 -1.21454039085 71.4166265981 0.0 -1.21554039085 70.3680456225 0.0 -1.21654039085 69.000547509 0.0 -1.21754039085 67.8809509343 0.0 -1.21854039085 66.6189836793 0.0 -1.21954039085 65.4260833679 0.0 -1.22054039085 64.2751016551 0.0 -1.22154039085 63.1686101957 0.0 -1.22254039085 61.9830457316 0.0 -1.22354039085 63.3614106955 0.0 -1.22454039085 61.9662571779 0.0 -1.22554039085 59.7273419246 0.0 -1.22654039085 56.8120063347 0.0 -1.22754039085 53.4588702908 0.0 -1.22854039085 50.5523589142 0.0 -1.22954039085 47.7091448711 0.0 -1.23054039085 45.4309067317 0.0 -1.23154039085 43.8011969689 0.0 -1.23254039085 41.7308785756 0.0 -1.23354039085 40.4311149539 0.0 -1.23454039085 39.406675752 0.0 -1.23554039085 38.4839199657 0.0 -1.23654039085 38.2484117248 0.0 -1.23754039085 35.680377657 0.0 -1.23854039085 33.3832648978 0.0 -1.23954039085 28.5059162344 0.0 -1.24054039085 26.3227315182 0.0 -1.24154039085 25.8506567856 0.0 -1.24254039085 26.3831338349 0.0 -1.24354039085 27.3055882099 0.0 -1.24454039085 28.0918762793 0.0 -1.24554039085 27.6454226891 0.0 -1.24654039085 27.5334002527 0.0 -1.24754039085 27.7328812323 0.0 -1.24854039085 28.0484030208 0.0 -1.24954039085 28.3770056 0.0 -1.25054039085 28.4914317762 0.0 -1.25154039085 28.7549327949 0.0 -1.25254039085 28.1713235406 0.0 -1.25354039085 33.9365893273 0.0 -1.25454039085 28.3609868621 0.0 -1.25554039085 26.0165538546 0.0 -1.25654039085 23.9204783013 0.0 -1.25754039085 22.465016098 0.0 -1.25854039085 21.3992619393 0.0 -1.25954039085 20.6888720978 0.0 -1.26054039085 20.4826251974 0.0 -1.26154039085 20.5863649826 0.0 -1.26254039085 20.6455061908 0.0 -1.26354039085 20.7016826046 0.0 -1.26454039085 20.7703462152 0.0 -1.26554039085 18.4175542198 0.0 -1.26654039085 16.8245302999 0.0 -1.26754039085 16.137591322 0.0 -1.26854039085 22.0534483039 0.0 -1.26954039085 24.3879960214 0.0 -1.27054039085 25.3774192865 0.0 -1.27154039085 25.0645955343 0.0 -1.27254039085 25.3961810432 0.0 -1.27354039085 24.9807466763 0.0 -1.27454039085 23.8993237272 0.0 -1.27554039085 22.7595699811 0.0 -1.27654039085 21.6426915284 0.0 -1.27754039085 20.4457816864 0.0 -1.27854039085 19.3626427314 0.0 -1.27954039085 18.5582586693 0.0 -1.28054039085 17.4298019073 0.0 -1.28154039085 22.9208488729 0.0 -1.28254039085 20.8405165525 0.0 -1.28354039085 17.4304489677 0.0 -1.28454039085 16.8234858952 0.0 -1.28554039085 15.7316011649 0.0 -1.28654039085 14.9164767335 0.0 -1.28754039085 13.7068837958 0.0 -1.28854039085 13.1504255583 0.0 -1.28954039085 12.9599362933 0.0 -1.29054039085 13.0851081418 0.0 -1.29154039085 13.384397243 0.0 -1.29254039085 13.6274934919 0.0 -1.29354039085 13.365377773 0.0 -1.29454039085 13.0525614298 0.0 -1.29554039085 12.7401388915 0.0 -1.29654039085 10.7724861735 0.0 -1.29754039085 9.27884048191 0.0 -1.29854039085 9.4752081083 0.0 -1.29954039085 9.03703402156 0.0 -1.30054039085 6.65380405392 0.0 -1.30154039085 3.96621008249 0.0 -1.30254039085 1.88183025926 0.0 -1.30354039085 0.400120263895 0.0 -1.30454039085 -0.836757136202 0.0 -1.30554039085 -1.84163934108 0.0 -1.30654039085 -2.62190446533 0.0 -1.30754039085 -3.00617634695 0.0 -1.30854039085 -2.82387867735 0.0 -1.30954039085 -2.43518768273 0.0 -1.31054039085 -2.1863578241 0.0 -1.31154039085 -3.18190083493 0.0 -1.31254039085 -2.91028381379 0.0 -1.31354039085 -2.52105349579 0.0 -1.31454039085 -2.69959186031 0.0 -1.31554039085 -3.06943768086 0.0 -1.31654039085 -3.55106112962 0.0 -1.31754039085 -1.93595992754 0.0 -1.31854039085 -2.91138958186 0.0 -1.31954039085 -5.05846602062 0.0 -1.32054039085 -6.38027548726 0.0 -1.32154039085 -9.62698036768 0.0 -1.32254039085 -13.2275080226 0.0 -1.32354039085 -15.3537227225 0.0 -1.32454039085 -15.9197610334 0.0 -1.32554039085 -15.4132608069 0.0 -1.32654039085 -14.3428677335 0.0 -1.32754039085 -13.1527025901 0.0 -1.32854039085 -12.2283823894 0.0 -1.32954039085 -11.8308846408 0.0 -1.33054039085 -12.1388714735 0.0 -1.33154039085 -13.1795545667 0.0 -1.33254039085 -12.888127337 0.0 -1.33354039085 -6.33249779141 0.0 -1.33454039085 1.23583021751 0.0 -1.33554039085 -3.09569988426 0.0 -1.33654039085 -9.10131378472 0.0 -1.33754039085 -15.6380621812 0.0 -1.33854039085 -15.6380621812 0.0 -1.33954039085 -15.6380621812 0.0 -1.34054039085 -15.6380621812 0.0 -1.34154039085 -15.6380621812 0.0 -1.34254039085 -15.6380621812 0.0 -1.34354039085 -15.6380621812 0.0 -1.34454039085 -15.6380621812 0.0 -1.34554039085 -15.6380621812 0.0 -1.34654039085 -15.6380621812 0.0 -1.34754039085 -15.6380621812 0.0 -1.34854039085 -15.6380621812 0.0 -1.34954039085 -15.6380621812 0.0 -1.35054039085 -15.6380621812 0.0 -1.35154039085 -15.6380621812 0.0 -1.35254039085 -15.6380621812 0.0 -1.35354039085 -15.6380621812 0.0 -1.35454039085 -15.6380621812 0.0 -1.35554039085 -15.6380621812 0.0 -1.35654039085 -15.6380621812 0.0 -1.35754039085 -15.6380621812 0.0 -1.35854039085 -15.6380621812 0.0 -1.35954039085 -15.6380621812 0.0 -1.36054039085 -15.6380621812 0.0 -1.36154039085 -15.6380621812 0.0 -1.36254039085 -15.6380621812 0.0 -1.36354039085 -15.6380621812 0.0 -1.36454039085 -15.6380621812 0.0 -1.36554039085 -15.6380621812 0.0 -1.36654039085 -15.6380621812 0.0 -1.36754039085 -15.6380621812 0.0 -1.36854039085 -15.6380621812 0.0 -1.36954039085 -15.6380621812 0.0 -1.37054039085 -15.6380621812 0.0 -1.37154039085 -15.6380621812 0.0 -1.37254039085 -15.6380621812 0.0 -1.37354039085 -15.6380621812 0.0 -1.37454039085 -15.6380621812 0.0 -1.37554039085 -15.6380621812 0.0 -1.37654039085 -15.6380621812 0.0 -1.37754039085 -15.6380621812 0.0 -1.37854039085 -15.6380621812 0.0 -1.37954039085 -15.6380621812 0.0 -1.38054039085 -15.6380621812 0.0 -1.38154039085 -15.6380621812 0.0 -1.38254039085 -15.6380621812 0.0 -1.38354039085 -15.6380621812 0.0 -1.38454039085 -15.6380621812 0.0 -1.38554039085 -15.6380621812 0.0 -1.38654039085 -15.6380621812 0.0 -1.38754039085 -15.6380621812 0.0 -1.38854039085 -15.6380621812 0.0 -1.38954039085 -15.6380621812 0.0 -1.39054039085 -15.6380621812 0.0 -1.39154039085 -15.6380621812 0.0 -1.39254039085 -15.6380621812 0.0 -1.39354039085 -15.6380621812 0.0 -1.39454039085 -15.6380621812 0.0 -1.39554039085 -15.6380621812 0.0 -1.39654039085 -15.6380621812 0.0 -1.39754039085 -15.6380621812 0.0 -1.39854039085 -15.6380621812 0.0 -1.39954039085 -15.6380621812 0.0 -1.40054039085 -15.6380621812 0.0 -1.40154039085 -15.6380621812 0.0 -1.40254039085 -15.6380621812 0.0 -1.40354039085 -15.6380621812 0.0 -1.40454039085 -15.6380621812 0.0 -1.40554039085 -15.6380621812 0.0 -1.40654039085 -15.6380621812 0.0 -1.40754039085 -15.6380621812 0.0 -1.40854039085 -15.6380621812 0.0 -1.40954039085 -15.6380621812 0.0 -1.41054039085 -15.6380621812 0.0 -1.41154039085 -15.6380621812 0.0 -1.41254039085 -15.6380621812 0.0 -1.41354039085 -15.6380621812 0.0 -1.41454039085 -15.6380621812 0.0 -1.41554039085 -15.6380621812 0.0 -1.41654039085 -15.6380621812 0.0 -1.41754039085 -15.6380621812 0.0 -1.41854039085 -15.6380621812 0.0 -1.41954039085 -15.6380621812 0.0 -1.42054039085 -15.6380621812 0.0 -1.42154039085 -15.6380621812 0.0 -1.42254039085 -15.6380621812 0.0 -1.42354039085 -15.6380621812 0.0 -1.42454039085 -15.6380621812 0.0 -1.42554039085 -15.6380621812 0.0 -1.42654039085 -15.6380621812 0.0 -1.42754039085 -15.6380621812 0.0 -1.42854039085 -15.6380621812 0.0 -1.42954039085 -15.6380621812 0.0 -1.43054039085 -15.6380621812 0.0 -1.43154039085 -15.6380621812 0.0 -1.43254039085 -15.6380621812 0.0 -1.43354039085 -15.6380621812 0.0 -1.43454039085 -15.6380621812 0.0 -1.43554039085 -15.6380621812 0.0 -1.43654039085 -15.6380621812 0.0 -1.43754039085 -15.6380621812 0.0 -1.43854039085 -15.6380621812 0.0 -1.43954039085 -15.6380621812 0.0 -1.44054039085 -15.6380621812 0.0 -1.44154039085 -15.6380621812 0.0 -1.44254039085 -15.6380621812 0.0 -1.44354039085 -15.6380621812 0.0 -1.44454039085 -15.6380621812 0.0 -1.44554039085 -15.6380621812 0.0 -1.44654039085 -15.6380621812 0.0 -1.44754039085 -15.6380621812 0.0 -1.44854039085 -15.6380621812 0.0 -1.44954039085 -15.6380621812 0.0 -1.45054039085 -15.6380621812 0.0 -1.45154039085 -15.6380621812 0.0 -1.45254039085 -15.6380621812 0.0 -1.45354039085 -15.6380621812 0.0 -1.45454039085 -15.6380621812 0.0 -1.45554039085 -15.6380621812 0.0 -1.45654039085 -15.6380621812 0.0 -1.45754039085 -15.6380621812 0.0 -1.45854039085 -15.6380621812 0.0 -1.45954039085 -15.6380621812 0.0 -1.46054039085 -15.6380621812 0.0 -1.46154039085 -15.6380621812 0.0 -1.46254039085 -15.6380621812 0.0 -1.46354039085 -15.6380621812 0.0 -1.46454039085 -15.6380621812 0.0 -1.46554039085 -15.6380621812 0.0 -1.46654039085 -15.6380621812 0.0 -1.46754039085 -15.6380621812 0.0 -1.46854039085 -15.6380621812 0.0 -1.46954039085 -15.6380621812 0.0 -1.47054039085 -15.6380621812 0.0 -1.47154039085 -15.6380621812 0.0 -1.47254039085 -15.6380621812 0.0 -1.47354039085 -15.6380621812 0.0 -1.47454039085 -15.6380621812 0.0 -1.47554039085 -15.6380621812 0.0 -1.47654039085 -15.6380621812 0.0 -1.47754039085 -15.6380621812 0.0 -1.47854039085 -15.6380621812 0.0 -1.47954039085 -15.6380621812 0.0 -1.48054039085 -15.6380621812 0.0 -1.48154039085 -15.6380621812 0.0 -1.48254039085 -15.6380621812 0.0 -1.48354039085 -15.6380621812 0.0 -1.48454039085 -15.6380621812 0.0 -1.48554039085 -15.6380621812 0.0 -1.48654039085 -15.6380621812 0.0 -1.48754039085 -15.6380621812 0.0 -1.48854039085 -15.6380621812 0.0 -1.48954039085 -15.6380621812 0.0 -1.49054039085 -15.6380621812 0.0 -1.49154039085 -15.6380621812 0.0 -1.49254039085 -15.6380621812 0.0 -1.49354039085 -15.6380621812 0.0 -1.49454039085 -15.6380621812 0.0 -1.49554039085 -15.6380621812 0.0 -1.49654039085 -15.6380621812 0.0 -1.49754039085 -15.6380621812 0.0 -1.49854039085 -15.6380621812 0.0 -1.49954039085 -15.6380621812 0.0 -1.50054039085 -15.6380621812 0.0 -1.50154039085 -15.6380621812 0.0 -1.50254039085 -15.6380621812 0.0 -1.50354039085 -15.6380621812 0.0 -1.50454039085 -15.6380621812 0.0 -1.50554039085 -15.6380621812 0.0 -1.50654039085 -15.6380621812 0.0 -1.50754039085 -15.6380621812 0.0 -1.50854039085 -15.6380621812 0.0 -1.50954039085 -15.6380621812 0.0 -1.51054039085 -15.6380621812 0.0 -1.51154039085 -15.6380621812 0.0 -1.51254039085 -15.6380621812 0.0 -1.51354039085 -15.6380621812 0.0 -1.51454039085 -15.6380621812 0.0 -1.51554039085 -15.6380621812 0.0 -1.51654039085 -15.6380621812 0.0 -1.51754039085 -15.6380621812 0.0 -1.51854039085 -15.6380621812 0.0 -1.51954039085 -15.6380621812 0.0 -1.52054039085 -15.6380621812 0.0 -1.52154039085 -15.6380621812 0.0 -1.52254039085 -15.6380621812 0.0 -1.52354039085 -15.6380621812 0.0 -1.52454039085 -15.6380621812 0.0 -1.52554039085 -15.6380621812 0.0 -1.52654039085 -15.6380621812 0.0 -1.52754039085 -15.6380621812 0.0 -1.52854039085 -15.6380621812 0.0 -1.52954039085 -15.6380621812 0.0 -1.53054039085 -15.6380621812 0.0 -1.53154039085 -15.6380621812 0.0 -1.53254039085 -15.6380621812 0.0 -1.53354039085 -15.6380621812 0.0 -1.53454039085 -15.6380621812 0.0 -1.53554039085 -15.6380621812 0.0 -1.53654039085 -15.6380621812 0.0 -1.53754039085 -15.6380621812 0.0 -1.53854039085 -15.6380621812 0.0 -1.53954039085 -15.6380621812 0.0 -1.54054039085 -15.6380621812 0.0 -1.54154039085 -15.6380621812 0.0 -1.54254039085 -15.6380621812 0.0 -1.54354039085 -15.6380621812 0.0 -1.54454039085 -15.6380621812 0.0 -1.54554039085 -15.6380621812 0.0 -1.54654039085 -15.6380621812 0.0 -1.54754039085 -15.6380621812 0.0 -1.54854039085 -15.6380621812 0.0 -1.54954039085 -15.6380621812 0.0 -1.55054039085 -15.6380621812 0.0 -1.55154039085 -15.6380621812 0.0 -1.55254039085 -15.6380621812 0.0 -1.55354039085 -15.6380621812 0.0 -1.55454039085 -15.6380621812 0.0 -1.55554039085 -15.6380621812 0.0 -1.55654039085 -15.6380621812 0.0 -1.55754039085 -15.6380621812 0.0 -1.55854039085 -15.6380621812 0.0 -1.55954039085 -15.6380621812 0.0 -1.56054039085 -15.6380621812 0.0 -1.56154039085 -15.6380621812 0.0 -1.56254039085 -15.6380621812 0.0 -1.56354039085 -15.6380621812 0.0 -1.56454039085 -15.6380621812 0.0 -1.56554039085 -15.6380621812 0.0 -1.56654039085 -15.6380621812 0.0 -1.56754039085 -15.6380621812 0.0 -1.56854039085 -15.6380621812 0.0 -1.56954039085 -15.6380621812 0.0 -1.57054039085 -15.6380621812 0.0 -1.57154039085 -15.6380621812 0.0 -1.57254039085 -15.6380621812 0.0 -1.57354039085 -15.6380621812 0.0 -1.57454039085 -15.6380621812 0.0 -1.57554039085 -15.6380621812 0.0 -1.57654039085 -15.6380621812 0.0 -1.57754039085 -15.6380621812 0.0 -1.57854039085 -15.6380621812 0.0 -1.57954039085 -15.6380621812 0.0 -1.58054039085 -15.6380621812 0.0 -1.58154039085 -15.6380621812 0.0 -1.58254039085 -15.6380621812 0.0 -1.58354039085 -15.6380621812 0.0 -1.58454039085 -15.6380621812 0.0 -1.58554039085 -15.6380621812 0.0 -1.58654039085 -15.6380621812 0.0 -1.58754039085 -15.6380621812 0.0 -1.58854039085 -15.6380621812 0.0 -1.58954039085 -15.6380621812 0.0 -1.59054039085 -15.6380621812 0.0 -1.59154039085 -15.6380621812 0.0 -1.59254039085 -15.6380621812 0.0 -1.59354039085 -15.6380621812 0.0 -1.59454039085 -15.6380621812 0.0 -1.59554039085 -15.6380621812 0.0 -1.59654039085 -15.6380621812 0.0 -1.59754039085 -15.6380621812 0.0 -1.59854039085 -15.6380621812 0.0 -1.59954039085 -15.6380621812 0.0 -1.60054039085 -15.6380621812 0.0 -1.60154039085 -15.6380621812 0.0 -1.60254039085 -15.6380621812 0.0 -1.60354039085 -15.6380621812 0.0 -1.60454039085 -15.6380621812 0.0 -1.60554039085 -15.6380621812 0.0 -1.60654039085 -15.6380621812 0.0 -1.60754039085 -15.6380621812 0.0 -1.60854039085 -15.6380621812 0.0 -1.60954039085 -15.6380621812 0.0 -1.61054039085 -15.6380621812 0.0 -1.61154039085 -15.6380621812 0.0 -1.61254039085 -15.6380621812 0.0 -1.61354039085 -15.6380621812 0.0 -1.61454039085 -15.6380621812 0.0 -1.61554039085 -15.6380621812 0.0 -1.61654039085 -15.6380621812 0.0 -1.61754039085 -15.6380621812 0.0 -1.61854039085 -15.6380621812 0.0 -1.61954039085 -15.6380621812 0.0 -1.62054039085 -15.6380621812 0.0 -1.62154039085 -15.6380621812 0.0 -1.62254039085 -15.6380621812 0.0 -1.62354039085 -15.6380621812 0.0 -1.62454039085 -15.6380621812 0.0 -1.62554039085 -15.6380621812 0.0 -1.62654039085 -15.6380621812 0.0 -1.62754039085 -15.6380621812 0.0 -1.62854039085 -15.6380621812 0.0 -1.62954039085 -15.6380621812 0.0 -1.63054039085 -15.6380621812 0.0 -1.63154039085 -15.6380621812 0.0 -1.63254039085 -15.6380621812 0.0 -1.63354039085 -15.6380621812 0.0 -1.63454039085 -15.6380621812 0.0 -1.63554039085 -15.6380621812 0.0 -1.63654039085 -15.6380621812 0.0 -1.63754039085 -15.6380621812 0.0 -1.63854039085 -15.6380621812 0.0 -1.63954039085 -15.6380621812 0.0 -1.64054039085 -15.6380621812 0.0 -1.64154039085 -15.6380621812 0.0 -1.64254039085 -15.6380621812 0.0 -1.64354039085 -15.6380621812 0.0 -1.64454039085 -15.6380621812 0.0 -1.64554039085 -15.6380621812 0.0 -1.64654039085 -15.6380621812 0.0 -1.64754039085 -15.6380621812 0.0 -1.64854039085 -15.6380621812 0.0 -1.64954039085 -15.6380621812 0.0 -1.65054039085 -15.6380621812 0.0 -1.65154039085 -15.6380621812 0.0 -1.65254039085 -15.6380621812 0.0 -1.65354039085 -15.6380621812 0.0 -1.65454039085 -15.6380621812 0.0 -1.65554039085 -15.6380621812 0.0 -1.65654039085 -15.6380621812 0.0 -1.65754039085 -15.6380621812 0.0 -1.65854039085 -15.6380621812 0.0 -1.65954039085 -15.6380621812 0.0 -1.66054039085 -15.6380621812 0.0 -1.66154039085 -15.6380621812 0.0 -1.66254039085 -15.6380621812 0.0 -1.66354039085 -15.6380621812 0.0 -1.66454039085 -15.6380621812 0.0 -1.66554039085 -15.6380621812 0.0 -1.66654039085 -15.6380621812 0.0 -1.66754039085 -15.6380621812 0.0 -1.66854039085 -15.6380621812 0.0 -1.66954039085 -15.6380621812 0.0 -1.67054039085 -15.6380621812 0.0 -1.67154039085 -15.6380621812 0.0 -1.67254039085 -15.6380621812 0.0 -1.67354039085 -15.6380621812 0.0 -1.67454039085 -15.6380621812 0.0 -1.67554039085 -15.6380621812 0.0 -1.67654039085 -15.6380621812 0.0 -1.67754039085 -15.6380621812 0.0 -1.67854039085 -15.6380621812 0.0 -1.67954039085 -15.6380621812 0.0 -1.68054039085 -15.6380621812 0.0 -1.68154039085 -15.6380621812 0.0 -1.68254039085 -15.6380621812 0.0 -1.68354039085 -15.6380621812 0.0 -1.68454039085 -15.6380621812 0.0 -1.68554039085 -15.6380621812 0.0 -1.68654039085 -15.6380621812 0.0 -1.68754039085 -15.6380621812 0.0 -1.68854039085 -15.6380621812 0.0 -1.68954039085 -15.6380621812 0.0 -1.69054039085 -15.6380621812 0.0 -1.69154039085 -15.6380621812 0.0 -1.69254039085 -15.6380621812 0.0 -1.69354039085 -15.6380621812 0.0 -1.69454039085 -15.6380621812 0.0 -1.69554039085 -15.6380621812 0.0 -1.69654039085 -15.6380621812 0.0 -1.69754039085 -15.6380621812 0.0 -1.69854039085 -15.6380621812 0.0 -1.69954039085 -15.6380621812 0.0 -1.70054039085 -15.6380621812 0.0 -1.70154039085 -15.6380621812 0.0 -1.70254039085 -15.6380621812 0.0 -1.70354039085 -15.6380621812 0.0 -1.70454039085 -15.6380621812 0.0 -1.70554039085 -15.6380621812 0.0 -1.70654039085 -15.6380621812 0.0 -1.70754039085 -15.6380621812 0.0 -1.70854039085 -15.6380621812 0.0 -1.70954039085 -15.6380621812 0.0 -1.71054039085 -15.6380621812 0.0 -1.71154039085 -15.6380621812 0.0 -1.71254039085 -15.6380621812 0.0 -1.71354039085 -15.6380621812 0.0 -1.71454039085 -15.6380621812 0.0 -1.71554039085 -15.6380621812 0.0 -1.71654039085 -15.6380621812 0.0 -1.71754039085 -15.6380621812 0.0 -1.71854039085 -15.6380621812 0.0 -1.71954039085 -15.6380621812 0.0 -1.72054039085 -15.6380621812 0.0 -1.72154039085 -15.6380621812 0.0 -1.72254039085 -15.6380621812 0.0 -1.72354039085 -15.6380621812 0.0 -1.72454039085 -15.6380621812 0.0 -1.72554039085 -15.6380621812 0.0 -1.72654039085 -15.6380621812 0.0 -1.72754039085 -15.6380621812 0.0 -1.72854039085 -15.6380621812 0.0 -1.72954039085 -15.6380621812 0.0 -1.73054039085 -15.6380621812 0.0 -1.73154039085 -15.6380621812 0.0 -1.73254039085 -15.6380621812 0.0 -1.73354039085 -15.6380621812 0.0 -1.73454039085 -15.6380621812 0.0 -1.73554039085 -15.6380621812 0.0 -1.73654039085 -15.6380621812 0.0 -1.73754039085 -15.6380621812 0.0 -1.73854039085 -15.6380621812 0.0 -1.73954039085 -15.6380621812 0.0 -1.74054039085 -15.6380621812 0.0 -1.74154039085 -15.6380621812 0.0 -1.74254039085 -15.6380621812 0.0 -1.74354039085 -15.6380621812 0.0 -1.74454039085 -15.6380621812 0.0 -1.74554039085 -15.6380621812 0.0 -1.74654039085 -15.6380621812 0.0 -1.74754039085 -15.6380621812 0.0 -1.74854039085 -15.6380621812 0.0 -1.74954039085 -15.6380621812 0.0 -1.75054039085 -15.6380621812 0.0 -1.75154039085 -15.6380621812 0.0 -1.75254039085 -15.6380621812 0.0 -1.75354039085 -15.6380621812 0.0 -1.75454039085 -15.6380621812 0.0 -1.75554039085 -15.6380621812 0.0 -1.75654039085 -15.6380621812 0.0 -1.75754039085 -15.6380621812 0.0 -1.75854039085 -15.6380621812 0.0 -1.75954039085 -15.6380621812 0.0 -1.76054039085 -15.6380621812 0.0 -1.76154039085 -15.6380621812 0.0 -1.76254039085 -15.6380621812 0.0 -1.76354039085 -15.6380621812 0.0 -1.76454039085 -15.6380621812 0.0 -1.76554039085 -15.6380621812 0.0 -1.76654039085 -15.6380621812 0.0 -1.76754039085 -15.6380621812 0.0 -1.76854039085 -15.6380621812 0.0 -1.76954039085 -15.6380621812 0.0 -1.77054039085 -15.6380621812 0.0 -1.77154039085 -15.6380621812 0.0 -1.77254039085 -15.6380621812 0.0 -1.77354039085 -15.6380621812 0.0 -1.77454039085 -15.6380621812 0.0 -1.77554039085 -15.6380621812 0.0 -1.77654039085 -15.6380621812 0.0 -1.77754039085 -15.6380621812 0.0 -1.77854039085 -15.6380621812 0.0 -1.77954039085 -15.6380621812 0.0 -1.78054039085 -15.6380621812 0.0 -1.78154039085 -15.6380621812 0.0 -1.78254039085 -15.6380621812 0.0 -1.78354039085 -15.6380621812 0.0 -1.78454039085 -15.6380621812 0.0 -1.78554039085 -15.6380621812 0.0 -1.78654039085 -15.6380621812 0.0 -1.78754039085 -15.6380621812 0.0 -1.78854039085 -15.6380621812 0.0 -1.78954039085 -15.6380621812 0.0 -1.79054039085 -15.6380621812 0.0 -1.79154039085 -15.6380621812 0.0 -1.79254039085 -15.6380621812 0.0 -1.79354039085 -15.6380621812 0.0 -1.79454039085 -15.6380621812 0.0 -1.79554039085 -15.6380621812 0.0 -1.79654039085 -15.6380621812 0.0 -1.79754039085 -15.6380621812 0.0 -1.79854039085 -15.6380621812 0.0 -1.79954039085 -15.6380621812 0.0 -1.80054039085 -15.6380621812 0.0 -1.80154039085 -15.6380621812 0.0 -1.80254039085 -15.6380621812 0.0 -1.80354039085 -15.6380621812 0.0 -1.80454039085 -15.6380621812 0.0 -1.80554039085 -15.6380621812 0.0 -1.80654039085 -15.6380621812 0.0 -1.80754039085 -15.6380621812 0.0 -1.80854039085 -15.6380621812 0.0 -1.80954039085 -15.6380621812 0.0 -1.81054039085 -15.6380621812 0.0 -1.81154039085 -15.6380621812 0.0 -1.81254039085 -15.6380621812 0.0 -1.81354039085 -15.6380621812 0.0 -1.81454039085 -15.6380621812 0.0 -1.81554039085 -15.6380621812 0.0 -1.81654039085 -15.6380621812 0.0 -1.81754039085 -15.6380621812 0.0 -1.81854039085 -15.6380621812 0.0 -1.81954039085 -15.6380621812 0.0 -1.82054039085 -15.6380621812 0.0 -1.82154039085 -15.6380621812 0.0 -1.82254039085 -15.6380621812 0.0 -1.82354039085 -15.6380621812 0.0 -1.82454039085 -15.6380621812 0.0 -1.82554039085 -15.6380621812 0.0 -1.82654039085 -15.6380621812 0.0 -1.82754039085 -15.6380621812 0.0 -1.82854039085 -15.6380621812 0.0 -1.82954039085 -15.6380621812 0.0 -1.83054039085 -15.6380621812 0.0 -1.83154039085 -15.6380621812 0.0 -1.83254039085 -15.6380621812 0.0 -1.83354039085 -15.6380621812 0.0 -1.83454039085 -15.6380621812 0.0 -1.83554039085 -15.6380621812 0.0 -1.83654039085 -15.6380621812 0.0 -1.83754039085 -15.6380621812 0.0 -1.83854039085 -15.6380621812 0.0 -1.83954039085 -15.6380621812 0.0 -1.84054039085 -15.6380621812 0.0 -1.84154039085 -15.6380621812 0.0 -1.84254039085 -15.6380621812 0.0 -1.84354039085 -15.6380621812 0.0 -1.84454039085 -15.6380621812 0.0 -1.84554039085 -15.6380621812 0.0 -1.84654039085 -15.6380621812 0.0 -1.84754039085 -15.6380621812 0.0 -1.84854039085 -15.6380621812 0.0 -1.84954039085 -15.6380621812 0.0 -1.85054039085 -15.6380621812 0.0 -1.85154039085 -15.6380621812 0.0 -1.85254039085 -15.6380621812 0.0 -1.85354039085 -15.6380621812 0.0 -1.85454039085 -15.6380621812 0.0 -1.85554039085 -15.6380621812 0.0 -1.85668909264 -15.6380621812 0.0 -1.85768909264 -15.6380621812 0.0 -1.85868909264 -15.6380621812 0.0 -1.85968909264 -15.6380621812 0.0 -1.86068909264 -15.6380621812 0.0 -1.86168909264 -15.6380621812 0.0 -1.86268909264 -15.6380621812 0.0 -1.86368909264 -15.6380621812 0.0 -1.86468909264 -15.6380621812 0.0 -1.86568909264 -15.6380621812 0.0 -1.86668909264 -15.6380621812 0.0 -1.86768909264 -15.6380621812 0.0 -1.86868909264 -15.6380621812 0.0 -1.86968909264 -15.6380621812 0.0 -1.87068909264 -15.6380621812 0.0 -1.87168909264 -15.6380621812 0.0 -1.87268909264 -15.6380621812 0.0 -1.87368909264 -15.6380621812 0.0 -1.87468909264 -15.6380621812 0.0 -1.87568909264 -15.6380621812 0.0 -1.87668909264 -15.6380621812 0.0 -1.87768909264 -15.6380621812 0.0 -1.87868909264 -15.6380621812 0.0 -1.87968909264 -15.6380621812 0.0 -1.88068909264 -15.6380621812 0.0 -1.88168909264 -15.6380621812 0.0 -1.88268909264 -15.6380621812 0.0 -1.88368909264 -15.6380621812 0.0 -1.88468909264 -15.6380621812 0.0 -1.88603981813 -15.6380621812 0.0 -1.88703981813 -15.6380621812 0.0 -1.88803981813 -15.6380621812 0.0 -1.88903981813 -15.6380621812 0.0 -1.89003981813 -15.6380621812 0.0 -1.89103981813 -15.6380621812 0.0 -1.89203981813 -15.6380621812 0.0 -1.89303981813 -15.6380621812 0.0 -1.89403981813 -15.6380621812 0.0 -1.89503981813 -15.6380621812 0.0 -1.89603981813 -15.6380621812 0.0 -1.89703981813 -15.6380621812 0.0 -1.89803981813 -15.6380621812 0.0 -1.89903981813 -15.6380621812 0.0 -1.90003981813 -15.6380621812 0.0 -1.90103981813 -15.6380621812 0.0 -1.90203981813 -15.6380621812 0.0 -1.90303981813 -15.6380621812 0.0 -1.90403981813 -15.6380621812 0.0 -1.90503981813 -15.6380621812 0.0 -1.90603981813 -15.6380621812 0.0 -1.90703981813 -15.6380621812 0.0 -1.90803981813 -15.6380621812 0.0 -1.90903981813 -15.6380621812 0.0 -1.91003981813 -15.6380621812 0.0 -1.91103981813 -15.6380621812 0.0 -1.91203981813 -15.6380621812 0.0 -1.91303981813 -15.6380621812 0.0 -1.91403981813 -15.6380621812 0.0 -1.91503981813 -15.6380621812 0.0 -1.91603981813 -15.6380621812 0.0 -1.91703981813 -15.6380621812 0.0 -1.91803981813 -15.6380621812 0.0 -1.91903981813 -15.6380621812 0.0 -1.92003981813 -15.6380621812 0.0 -1.92103981813 -15.6380621812 0.0 -1.92203981813 -15.6380621812 0.0 -1.92303981813 -15.6380621812 0.0 -1.92403981813 -15.6380621812 0.0 -1.92503981813 -15.6380621812 0.0 -1.92603981813 -15.6380621812 0.0 -1.92703981813 -15.6380621812 0.0 -1.92803981813 -15.6380621812 0.0 -1.92903981813 -15.6380621812 0.0 -1.93003981813 -15.6380621812 0.0 -1.93103981813 -15.6380621812 0.0 -1.93203981813 -15.6380621812 0.0 -1.93303981813 -15.6380621812 0.0 -1.93403981813 -15.6380621812 0.0 -1.93503981813 -15.6380621812 0.0 -1.93603981813 -15.6380621812 0.0 -1.93703981813 -15.6380621812 0.0 -1.93803981813 -15.6380621812 0.0 -1.93903981813 -15.6380621812 0.0 -1.94003981813 -15.6380621812 0.0 -1.94103981813 -15.6380621812 0.0 -1.94203981813 -15.6380621812 0.0 -1.94303981813 -15.6380621812 0.0 -1.94403981813 -15.6380621812 0.0 -1.94503981813 -15.6380621812 0.0 -1.94603981813 -15.6380621812 0.0 -1.94703981813 -15.6380621812 0.0 -1.94803981813 -15.6380621812 0.0 -1.94903981813 -15.6380621812 0.0 -1.95003981813 -15.6380621812 0.0 -1.95103981813 -15.6380621812 0.0 -1.95203981813 -15.6380621812 0.0 -1.95303981813 -15.6380621812 0.0 -1.95403981813 -15.6380621812 0.0 -1.95503981813 -15.6380621812 0.0 -1.95603981813 -15.6380621812 0.0 -1.95703981813 -15.6380621812 0.0 -1.95803981813 -15.6380621812 0.0 -1.95903981813 -15.6380621812 0.0 -1.96003981813 -15.6380621812 0.0 -1.96103981813 -15.6380621812 0.0 -1.96203981813 -15.6380621812 0.0 -1.96303981813 -15.6380621812 0.0 -1.96403981813 -15.6380621812 0.0 -1.96503981813 -15.6380621812 0.0 -1.96603981813 -15.6380621812 0.0 -1.96703981813 -15.6380621812 0.0 -1.96803981813 -15.6380621812 0.0 -1.96903981813 -15.6380621812 0.0 -1.97003981813 -15.6380621812 0.0 -1.97103981813 -15.6380621812 0.0 -1.97203981813 -15.6380621812 0.0 -1.97303981813 -15.6380621812 0.0 -1.97403981813 -15.6380621812 0.0 -1.97503981813 -15.6380621812 0.0 -1.97603981813 -15.6380621812 0.0 -1.97703981813 -15.6380621812 0.0 -1.97803981813 -15.6380621812 0.0 -1.97903981813 -15.6380621812 0.0 -1.98003981813 -15.6380621812 0.0 -1.98103981813 -15.6380621812 0.0 -1.98203981813 -15.6380621812 0.0 -1.98303981813 -15.6380621812 0.0 -1.98403981813 -15.6380621812 0.0 -1.98503981813 -15.6380621812 0.0 -1.98603981813 -15.6380621812 0.0 -1.98703981813 -15.6380621812 0.0 -1.98803981813 -15.6380621812 0.0 -1.98903981813 -15.6380621812 0.0 -1.99003981813 -15.6380621812 0.0 -1.99103981813 -15.6380621812 0.0 -1.99203981813 -15.6380621812 0.0 -1.99303981813 -15.6380621812 0.0 -1.99403981813 -15.6380621812 0.0 -1.99503981813 -15.6380621812 0.0 -1.99603981813 -15.6380621812 0.0 -1.99703981813 -15.6380621812 0.0 -1.99803981813 -15.6380621812 0.0 -1.99903981813 -15.6380621812 0.0 -2.00003981813 -15.6380621812 0.0 -2.00103981813 -15.6380621812 0.0 -2.00203981813 -15.6380621812 0.0 -2.00303981813 -15.6380621812 0.0 -2.00403981813 -15.6380621812 0.0 -2.00503981813 -15.6380621812 0.0 -2.00603981813 -15.6380621812 0.0 -2.00703981813 -15.6380621812 0.0 -2.00803981813 -15.6380621812 0.0 -2.00903981813 -15.6380621812 0.0 -2.01003981813 -15.6380621812 0.0 -2.01103981813 -15.6380621812 0.0 -2.01203981813 -15.6380621812 0.0 -2.01303981813 -15.6380621812 0.0 -2.01403981813 -15.6380621812 0.0 -2.01503981813 -15.6380621812 0.0 -2.01603981813 -15.6380621812 0.0 -2.01703981813 -15.6380621812 0.0 -2.01803981813 -15.6380621812 0.0 -2.01903981813 -15.6380621812 0.0 -2.02003981813 -15.6380621812 0.0 -2.02103981813 -15.6380621812 0.0 -2.02203981813 -15.6380621812 0.0 -2.02303981813 -15.6380621812 0.0 -2.02403981813 -15.6380621812 0.0 -2.02503981813 -15.6380621812 0.0 -2.02603981813 -15.6380621812 0.0 -2.02703981813 -15.6380621812 0.0 -2.02803981813 -15.6380621812 0.0 -2.02903981813 -15.6380621812 0.0 -2.03003981813 -15.6380621812 0.0 -2.03103981813 -15.6380621812 0.0 -2.03203981813 -15.6380621812 0.0 -2.03303981813 -15.6380621812 0.0 -2.03403981813 -15.6380621812 0.0 -2.03503981813 -15.6380621812 0.0 -2.03603981813 -15.6380621812 0.0 -2.03703981813 -15.6380621812 0.0 -2.03803981813 -15.6380621812 0.0 -2.03903981813 -15.6380621812 0.0 -2.04003981813 -15.6380621812 0.0 -2.04103981813 -15.6380621812 0.0 -2.04203981813 -15.6380621812 0.0 -2.04303981813 -15.6380621812 0.0 -2.04403981813 -15.6380621812 0.0 -2.04503981813 -15.6380621812 0.0 -2.04603981813 -15.6380621812 0.0 -2.04703981813 -15.6380621812 0.0 -2.04803981813 -15.6380621812 0.0 -2.04903981813 -15.6380621812 0.0 -2.05003981813 -15.6380621812 0.0 -2.05103981813 -15.6380621812 0.0 -2.05203981813 -15.6380621812 0.0 -2.05303981813 -15.6380621812 0.0 -2.05403981813 -15.6380621812 0.0 -2.05503981813 -15.6380621812 0.0 -2.05603981813 -15.6380621812 0.0 -2.05703981813 -15.6380621812 0.0 -2.05803981813 -15.6380621812 0.0 -2.05903981813 -15.6380621812 0.0 -2.06003981813 -15.6380621812 0.0 -2.06103981813 -15.6380621812 0.0 -2.06203981813 -15.6380621812 0.0 -2.06303981813 -15.6380621812 0.0 -2.06403981813 -15.6380621812 0.0 -2.06503981813 -15.6380621812 0.0 -2.06603981813 -15.6380621812 0.0 -2.06703981813 -15.6380621812 0.0 -2.06803981813 -15.6380621812 0.0 -2.06903981813 -15.6380621812 0.0 -2.07003981813 -15.6380621812 0.0 -2.07103981813 -15.6380621812 0.0 -2.07203981813 -15.6380621812 0.0 -2.07303981813 -15.6380621812 0.0 -2.07403981813 -15.6380621812 0.0 -2.07503981813 -15.6380621812 0.0 -2.07603981813 -15.6380621812 0.0 -2.07703981813 -15.6380621812 0.0 -2.07803981813 -15.6380621812 0.0 -2.07903981813 -15.6380621812 0.0 -2.08003981813 -15.6380621812 0.0 -2.08103981813 -15.6380621812 0.0 -2.08203981813 -15.6380621812 0.0 -2.08303981813 -15.6380621812 0.0 -2.08403981813 -15.6380621812 0.0 -2.08503981813 -15.6380621812 0.0 -2.08603981813 -15.6380621812 0.0 -2.08703981813 -15.6380621812 0.0 -2.08803981813 -15.6380621812 0.0 -2.08903981813 -15.6380621812 0.0 -2.09003981813 -15.6380621812 0.0 -2.09103981813 -15.6380621812 0.0 -2.09203981813 -15.6380621812 0.0 -2.09303981813 -15.6380621812 0.0 -2.09403981813 -15.6380621812 0.0 -2.09503981813 -15.6380621812 0.0 -2.09603981813 -15.6380621812 0.0 -2.09703981813 -15.6380621812 0.0 -2.09803981813 -15.6380621812 0.0 -2.09903981813 -15.6380621812 0.0 -2.10003981813 -15.6380621812 0.0 -2.10103981813 -15.6380621812 0.0 -2.10203981813 -15.6380621812 0.0 -2.10303981813 -15.6380621812 0.0 -2.10403981813 -15.6380621812 0.0 -2.10503981813 -15.6380621812 0.0 -2.10603981813 -15.6380621812 0.0 -2.10703981813 -15.6380621812 0.0 -2.10803981813 -15.6380621812 0.0 -2.10903981813 -15.6380621812 0.0 -2.11003981813 -15.6380621812 0.0 -2.11103981813 -15.6380621812 0.0 -2.11203981813 -15.6380621812 0.0 -2.11303981813 -15.6380621812 0.0 -2.11403981813 -15.6380621812 0.0 -2.11503981813 -15.6380621812 0.0 -2.11603981813 -15.6380621812 0.0 -2.11703981813 -15.6380621812 0.0 -2.11803981813 -15.6380621812 0.0 -2.11903981813 -15.6380621812 0.0 -2.12003981813 -15.6380621812 0.0 -2.12103981813 -15.6380621812 0.0 -2.12203981813 -15.6380621812 0.0 -2.12303981813 -15.6380621812 0.0 -2.12403981813 -15.6380621812 0.0 -2.12503981813 -15.6380621812 0.0 -2.12603981813 -15.6380621812 0.0 -2.12703981813 -15.6380621812 0.0 -2.12803981813 -15.6380621812 0.0 -2.12903981813 -15.6380621812 0.0 -2.13003981813 -15.6380621812 0.0 -2.13103981813 -15.6380621812 0.0 -2.13203981813 -15.6380621812 0.0 -2.13303981813 -15.6380621812 0.0 -2.13403981813 -15.6380621812 0.0 -2.13503981813 -15.6380621812 0.0 -2.13603981813 -15.6380621812 0.0 -2.13703981813 -15.6380621812 0.0 -2.13803981813 -15.6380621812 0.0 -2.13903981813 -15.6380621812 0.0 -2.14003981813 -15.6380621812 0.0 -2.14103981813 -15.6380621812 0.0 -2.14203981813 -15.6380621812 0.0 -2.14303981813 -15.6380621812 0.0 -2.14403981813 -15.6380621812 0.0 -2.14503981813 -15.6380621812 0.0 -2.14603981813 -15.6380621812 0.0 -2.14703981813 -15.6380621812 0.0 -2.14803981813 -15.6380621812 0.0 -2.14903981813 -15.6380621812 0.0 -2.15003981813 -15.6380621812 0.0 -2.15103981813 -15.6380621812 0.0 -2.15203981813 -15.6380621812 0.0 -2.15303981813 -15.6380621812 0.0 -2.15403981813 -15.6380621812 0.0 -2.15503981813 -15.6380621812 0.0 -2.15603981813 -15.6380621812 0.0 -2.15703981813 -15.6380621812 0.0 -2.15803981813 -15.6380621812 0.0 -2.15903981813 -15.6380621812 0.0 -2.16003981813 -15.6380621812 0.0 -2.16103981813 -15.6380621812 0.0 -2.16203981813 -15.6380621812 0.0 -2.16303981813 -15.6380621812 0.0 -2.16403981813 -15.6380621812 0.0 -2.16503981813 -15.6380621812 0.0 -2.16603981813 -15.6380621812 0.0 -2.16703981813 -15.6380621812 0.0 -2.16803981813 -15.6380621812 0.0 -2.16903981813 -15.6380621812 0.0 -2.17003981813 -15.6380621812 0.0 -2.17103981813 -15.6380621812 0.0 -2.17203981813 -15.6380621812 0.0 -2.17303981813 -15.6380621812 0.0 -2.17403981813 -15.6380621812 0.0 -2.17503981813 -15.6380621812 0.0 -2.17603981813 -15.6380621812 0.0 -2.17703981813 -15.6380621812 0.0 -2.17803981813 -15.6380621812 0.0 -2.17903981813 -15.6380621812 0.0 -2.18003981813 -15.6380621812 0.0 -2.18103981813 -15.6380621812 0.0 -2.18203981813 -15.6380621812 0.0 -2.18303981813 -15.6380621812 0.0 -2.18403981813 -15.6380621812 0.0 -2.18503981813 -15.6380621812 0.0 -2.18603981813 -15.6380621812 0.0 -2.18703981813 -15.6380621812 0.0 -2.18803981813 -15.6380621812 0.0 -2.18903981813 -15.6380621812 0.0 -2.19003981813 -15.6380621812 0.0 -2.19103981813 -15.6380621812 0.0 -2.19203981813 -15.6380621812 0.0 -2.19303981813 -15.6380621812 0.0 -2.19403981813 -15.6380621812 0.0 -2.19503981813 -15.6380621812 0.0 -2.19603981813 -15.6380621812 0.0 -2.19703981813 -15.6380621812 0.0 -2.19803981813 -15.6380621812 0.0 -2.19903981813 -15.6380621812 0.0 -2.20003981813 -15.6380621812 0.0 -2.20103981813 -15.6380621812 0.0 -2.20203981813 -15.6380621812 0.0 -2.20303981813 -15.6380621812 0.0 -2.20403981813 -15.6380621812 0.0 -2.20503981813 -15.6380621812 0.0 -2.20603981813 -15.6380621812 0.0 -2.20703981813 -15.6380621812 0.0 -2.20803981813 -15.6380621812 0.0 -2.20903981813 -15.6380621812 0.0 -2.21003981813 -15.6380621812 0.0 -2.21103981813 -15.6380621812 0.0 -2.21203981813 -15.6380621812 0.0 -2.21303981813 -15.6380621812 0.0 -2.21403981813 -15.6380621812 0.0 -2.21503981813 -15.6380621812 0.0 -2.21603981813 -15.6380621812 0.0 -2.21703981813 -15.6380621812 0.0 -2.21803981813 -15.6380621812 0.0 -2.21903981813 -15.6380621812 0.0 -2.22003981813 -15.6380621812 0.0 -2.22103981813 -15.6380621812 0.0 -2.22203981813 -15.6380621812 0.0 -2.22303981813 -15.6380621812 0.0 -2.22403981813 -15.6380621812 0.0 -2.22503981813 -15.6380621812 0.0 -2.22603981813 -15.6380621812 0.0 -2.22703981813 -15.6380621812 0.0 -2.22803981813 -15.6380621812 0.0 -2.22903981813 -15.6380621812 0.0 -2.23003981813 -15.6380621812 0.0 -2.23103981813 -15.6380621812 0.0 -2.23203981813 -15.6380621812 0.0 -2.23303981813 -15.6380621812 0.0 -2.23403981813 -15.6380621812 0.0 -2.23503981813 -15.6380621812 0.0 -2.23603981813 -15.6380621812 0.0 -2.23703981813 -15.6380621812 0.0 -2.23803981813 -15.6380621812 0.0 -2.23903981813 -15.6380621812 0.0 -2.24003981813 -15.6380621812 0.0 -2.24103981813 -15.6380621812 0.0 -2.24203981813 -15.6380621812 0.0 -2.24303981813 -15.6380621812 0.0 -2.24403981813 -15.6380621812 0.0 -2.24503981813 -15.6380621812 0.0 -2.24603981813 -15.6380621812 0.0 -2.24703981813 -15.6380621812 0.0 -2.24803981813 -15.6380621812 0.0 -2.24903981813 -15.6380621812 0.0 -2.25003981813 -15.6380621812 0.0 -2.25103981813 -15.6380621812 0.0 -2.25203981813 -15.6380621812 0.0 -2.25303981813 -15.6380621812 0.0 -2.25403981813 -15.6380621812 0.0 -2.25503981813 -15.6380621812 0.0 -2.25603981813 -15.6380621812 0.0 -2.25703981813 -15.6380621812 0.0 -2.25803981813 -15.6380621812 0.0 -2.25903981813 -15.6380621812 0.0 -2.26003981813 -15.6380621812 0.0 -2.26103981813 -15.6380621812 0.0 -2.26203981813 -15.6380621812 0.0 -2.26303981813 -15.6380621812 0.0 -2.26403981813 -15.6380621812 0.0 -2.26503981813 -15.6380621812 0.0 -2.26603981813 -15.6380621812 0.0 -2.26703981813 -15.6380621812 0.0 -2.26803981813 -15.6380621812 0.0 -2.26903981813 -15.6380621812 0.0 -2.27003981813 -15.6380621812 0.0 -2.27103981813 -15.6380621812 0.0 -2.27203981813 -15.6380621812 0.0 -2.27303981813 -15.6380621812 0.0 -2.27403981813 -15.6380621812 0.0 -2.27503981813 -15.6380621812 0.0 -2.27603981813 -15.6380621812 0.0 -2.27703981813 -15.6380621812 0.0 -2.27803981813 -15.6380621812 0.0 -2.27903981813 -15.6380621812 0.0 -2.28003981813 -15.6380621812 0.0 -2.28103981813 -15.6380621812 0.0 -2.28203981813 -15.6380621812 0.0 -2.28303981813 -15.6380621812 0.0 -2.28403981813 -15.6380621812 0.0 -2.28503981813 -15.6380621812 0.0 -2.28603981813 -15.6380621812 0.0 -2.28703981813 -15.6380621812 0.0 -2.28803981813 -15.6380621812 0.0 -2.28903981813 -15.6380621812 0.0 -2.29003981813 -15.6380621812 0.0 -2.29103981813 -15.6380621812 0.0 -2.29203981813 -15.6380621812 0.0 -2.29303981813 -15.6380621812 0.0 -2.29403981813 -15.6380621812 0.0 -2.29503981813 -15.6380621812 0.0 -2.29603981813 -15.6380621812 0.0 -2.29703981813 -15.6380621812 0.0 -2.29803981813 -15.6380621812 0.0 -2.29903981813 -15.6380621812 0.0 -2.30003981813 -15.6380621812 0.0 -2.30103981813 -15.6380621812 0.0 -2.30203981813 -15.6380621812 0.0 -2.30303981813 -15.6380621812 0.0 -2.30403981813 -15.6380621812 0.0 -2.30503981813 -15.6380621812 0.0 -2.30603981813 -15.6380621812 0.0 -2.30703981813 -15.6380621812 0.0 -2.30803981813 -15.6380621812 0.0 -2.30903981813 -15.6380621812 0.0 -2.31003981813 -15.6380621812 0.0 -2.31103981813 -15.6380621812 0.0 -2.31203981813 -15.6380621812 0.0 -2.31303981813 -15.6380621812 0.0 -2.31403981813 -15.6380621812 0.0 -2.31503981813 -15.6380621812 0.0 -2.31603981813 -15.6380621812 0.0 -2.31703981813 -15.6380621812 0.0 -2.31803981813 -15.6380621812 0.0 -2.31903981813 -15.6380621812 0.0 -2.32003981813 -15.6380621812 0.0 -2.32103981813 -15.6380621812 0.0 -2.32203981813 -15.6380621812 0.0 -2.32303981813 -15.6380621812 0.0 -2.32403981813 -15.6380621812 0.0 -2.32503981813 -15.6380621812 0.0 -2.32603981813 -15.6380621812 0.0 -2.32703981813 -15.6380621812 0.0 -2.32803981813 -15.6380621812 0.0 -2.32903981813 -15.6380621812 0.0 -2.33003981813 -15.6380621812 0.0 -2.33103981813 -15.6380621812 0.0 -2.33203981813 -15.6380621812 0.0 -2.33303981813 -15.6380621812 0.0 -2.33403981813 -15.6380621812 0.0 -2.33503981813 -15.6380621812 0.0 -2.33603981813 -15.6380621812 0.0 -2.33703981813 -15.6380621812 0.0 -2.33803981813 -15.6380621812 0.0 -2.33903981813 -15.6380621812 0.0 -2.34003981813 -15.6380621812 0.0 -2.34103981813 -15.6380621812 0.0 -2.34203981813 -15.6380621812 0.0 -2.34303981813 -15.6380621812 0.0 -2.34403981813 -15.6380621812 0.0 -2.34503981813 -15.6380621812 0.0 -2.34603981813 -15.6380621812 0.0 -2.34703981813 -15.6380621812 0.0 -2.34803981813 -15.6380621812 0.0 -2.34903981813 -15.6380621812 0.0 -2.35003981813 -15.6380621812 0.0 -2.35103981813 -15.6380621812 0.0 -2.35203981813 -15.6380621812 0.0 -2.35303981813 -15.6380621812 0.0 -2.35403981813 -15.6380621812 0.0 -2.35503981813 -15.6380621812 0.0 -2.35603981813 -15.6380621812 0.0 -2.35703981813 -15.6380621812 0.0 -2.35803981813 -15.6380621812 0.0 -2.35903981813 -15.6380621812 0.0 -2.36003981813 -15.6380621812 0.0 -2.36103981813 -15.6380621812 0.0 -2.36203981813 -15.6380621812 0.0 -2.36303981813 -15.6380621812 0.0 -2.36403981813 -15.6380621812 0.0 -2.36503981813 -15.6380621812 0.0 -2.36603981813 -15.6380621812 0.0 -2.36703981813 -15.6380621812 0.0 -2.36803981813 -15.6380621812 0.0 -2.36903981813 163.324848394 0.0 -2.37003981813 122.144603861 0.0 -2.37103981813 -25.0770218373 0.0 -2.37203981813 -22.5612658519 0.0 -2.37303981813 -79.433062608 0.0 -2.37403981813 20.0794809423 0.0 -2.37503981813 547.743014143 0.0 -2.37603981813 2740.45384004 0.0 -2.37703981813 4384.05223271 0.0 -2.37803981813 5467.59281353 0.0 -2.37903981813 6078.6738921 0.0 -2.38003981813 6085.44479001 0.0 -2.38103981813 5741.23903367 0.0 -2.38203981813 5151.61104239 0.0 -2.38303981813 4352.69825765 0.0 -2.38403981813 3549.38260897 0.0 -2.38503981813 2827.02734615 0.0 -2.38603981813 2118.66035133 0.0 -2.38703981813 1398.91804184 0.0 -2.38803981813 802.215667779 0.0 -2.38903981813 260.549766932 0.0 -2.39003981813 -142.760095353 0.0 -2.39103981813 -452.138790341 0.0 -2.39203981813 -664.812444341 0.0 -2.39303981813 -796.544267288 0.0 -2.39403981813 -867.126234663 0.0 -2.39503981813 -881.058552211 0.0 -2.39603981813 -819.862245138 0.0 -2.39703981813 -707.207233165 0.0 -2.39803981813 -558.71097456 0.0 -2.39903981813 -436.14770509 0.0 -2.40003981813 -226.292095253 0.0 -2.40103981813 -50.8624097214 0.0 -2.40203981813 133.443065918 0.0 -2.40303981813 339.85692411 0.0 -2.40403981813 567.101172204 0.0 -2.40503981813 761.036336521 0.0 -2.40603981813 958.784707454 0.0 -2.40703981813 1127.59153751 0.0 -2.40803981813 1266.94294185 0.0 -2.40903981813 1375.89194677 0.0 -2.41003981813 1470.23230667 0.0 -2.41103981813 1533.0094358 0.0 -2.41203981813 1555.58883039 0.0 -2.41303981813 1552.48796118 0.0 -2.41403981813 1507.40582861 0.0 -2.41503981813 1433.28342102 0.0 -2.41603981813 1341.0424943 0.0 -2.41703981813 1226.42313919 0.0 -2.41803981813 1109.02004403 0.0 -2.41903981813 996.368470558 0.0 -2.42003981813 870.779650851 0.0 -2.42103981813 758.199402946 0.0 -2.42203981813 647.122472823 0.0 -2.42303981813 557.0389264 0.0 -2.42403981813 477.87345365 0.0 -2.42503981813 415.286043353 0.0 -2.42603981813 365.5235653 0.0 -2.42703981813 323.616874847 0.0 -2.42803981813 283.026670227 0.0 -2.42903981813 250.867337021 0.0 -2.43003981813 245.691263166 0.0 -2.43103981813 240.171466703 0.0 -2.43203981813 231.417627378 0.0 -2.43303981813 227.742973625 0.0 -2.43403981813 241.238890864 0.0 -2.43503981813 268.697007906 0.0 -2.43603981813 300.356822621 0.0 -2.43703981813 336.542697681 0.0 -2.43803981813 383.80353512 0.0 -2.43903981813 430.783021085 0.0 -2.44003981813 477.339740759 0.0 -2.44103981813 523.888202184 0.0 -2.44203981813 563.890813273 0.0 -2.44303981813 599.013493099 0.0 -2.44403981813 632.603252707 0.0 -2.44503981813 659.521904066 0.0 -2.44603981813 682.381311968 1.81560563209 -2.44703981813 701.693968403 1.77975783362 -2.44803981813 713.839654502 1.68685947139 -2.44903981813 719.034671002 1.63933038417 -2.45003981813 726.708407888 1.56242441902 -2.45103981813 728.685159271 1.55244329623 -2.45203981813 727.215032579 1.55244329623 -2.45303981813 722.815571342 1.55244329623 -2.45403981813 716.80906069 1.55244329623 -2.45503981813 706.315910281 1.55244329623 -2.45603981813 693.781845166 1.55244329623 -2.45703981813 680.041379235 1.55244329623 -2.45803981813 663.718255222 1.55244329623 -2.45903981813 647.388763448 1.55244329623 -2.46003981813 630.513652765 1.55244329623 -2.46103981813 613.270877382 1.55244329623 -2.46203981813 592.796808055 1.55244329623 -2.46303981813 572.092701431 1.55244329623 -2.46403981813 551.800334504 1.55244329623 -2.46503981813 533.034709357 1.55244329623 -2.46603981813 515.276341907 2.28626591692 -2.46703981813 499.125220883 2.2633386116 -2.46803981813 483.634070594 2.18275447849 -2.46903981813 471.412969645 2.17312725372 -2.47003981813 462.676125272 2.13725896452 -2.47103981813 456.390664637 2.10673260523 -2.47203981813 451.886403326 2.06592946552 -2.47303981813 449.664615007 2.06592946552 -2.47403981813 449.868554355 2.06592946552 -2.47503981813 451.334591909 2.06592946552 -2.47603981813 454.068288767 2.06592946552 -2.47703981813 457.452870806 2.06592946552 -2.47803981813 463.602914301 2.06592946552 -2.47903981813 471.762684176 2.06592946552 -2.48003981813 482.277205874 2.06592946552 -2.48103981813 492.583678641 2.06592946552 -2.48203981813 505.621277267 2.06592946552 -2.48303981813 516.931552968 2.06592946552 -2.48403981813 529.043834442 2.06592946552 -2.48503981813 542.594755659 2.18415310045 -2.48603981813 555.198545723 2.17951296432 -2.48703981813 567.853021227 2.18547814642 -2.48803981813 581.348511833 2.1688405422 -2.48903981813 594.924085168 2.1674607019 -2.49003981813 607.05495124 2.17471887873 -2.49103981813 618.851498492 2.16544385586 -2.49203981813 630.491064218 2.16031487041 -2.49303981813 639.900383848 2.16367838234 -2.49403981813 647.104652688 2.16367838234 -2.49503981813 651.564740663 2.16367838234 -2.49603981813 653.460771807 2.16367838234 -2.49703981813 653.830726985 2.16367838234 -2.49803981813 652.903267897 2.16367838234 -2.49903981813 651.010511898 2.16367838234 -2.50003981813 647.606527332 2.16367838234 -2.50103981813 643.025099327 2.16367838234 -2.50203981813 638.197283395 2.16367838234 -2.50303981813 632.604559563 2.16367838234 -2.50403981813 625.957345388 2.16367838234 -2.50503981813 619.796319135 2.16367838234 -2.50603981813 618.633659495 2.16367838234 -2.50703981813 612.194865382 2.16367838234 -2.50803981813 604.555159205 2.16367838234 -2.50903981813 597.429310039 2.16367838234 -2.51003981813 590.875688655 2.16367838234 -2.51103981813 585.133055816 2.16367838234 -2.51203981813 579.954044322 2.16367838234 -2.51303981813 576.172550544 2.16367838234 -2.51403981813 573.096485824 2.16367838234 -2.51503981813 570.250792103 2.16367838234 -2.51603981813 568.369086257 2.16367838234 -2.51703981813 566.252920996 2.16367838234 -2.51803981813 564.793037174 2.16367838234 -2.51903981813 563.051709705 2.16367838234 -2.52003981813 562.68612494 2.16367838234 -2.52103981813 563.051748114 2.16367838234 -2.52203981813 563.814849753 2.16367838234 -2.52303981813 564.950741076 2.16367838234 -2.52403981813 569.024199183 2.16367838234 -2.52503981813 572.696565931 2.16367838234 -2.52603981813 576.876203349 2.16367838234 -2.52703981813 582.249292081 2.16367838234 -2.52803981813 586.927420833 2.16367838234 -2.52903981813 595.133669737 2.16367838234 -2.53003981813 600.738626308 2.16367838234 -2.53103981813 607.922960414 2.16367838234 -2.53203981813 614.856703497 2.16367838234 -2.53303981813 622.815911579 2.16367838234 -2.53403981813 629.633655752 2.16367838234 -2.53503981813 636.280057457 2.16367838234 -2.53603981813 640.98781147 2.16367838234 -2.53703981813 647.879476252 2.16367838234 -2.53803981813 652.722811257 2.16367838234 -2.53903981813 658.845774994 2.16367838234 -2.54003981813 663.725650428 2.16367838234 -2.54103981813 666.493103918 2.16367838234 -2.54203981813 671.095092238 2.16367838234 -2.54303981813 673.108259925 2.16367838234 -2.54403981813 675.301828396 2.16367838234 -2.54503981813 676.145174384 2.16367838234 -2.54603981813 677.897303155 2.16367838234 -2.54703981813 679.451952701 2.16367838234 -2.54803981813 679.944299374 2.16367838234 -2.54903981813 679.723717559 2.16367838234 -2.55003981813 679.381560415 2.16367838234 -2.55103981813 679.162365295 2.16367838234 -2.55203981813 678.967317276 2.16367838234 -2.55303981813 678.441474161 2.16367838234 -2.55403981813 677.725013969 2.16367838234 -2.55503981813 676.917935584 2.16367838234 -2.55603981813 676.015982942 2.16367838234 -2.55703981813 675.076814992 2.16367838234 -2.55803981813 674.106454943 2.16367838234 -2.55903981813 673.470167568 2.16367838234 -2.56003981813 673.690909327 2.16367838234 -2.56103981813 673.714972068 2.16367838234 -2.56203981813 674.304834152 2.16367838234 -2.56303981813 674.627482721 2.16367838234 -2.56403981813 676.578165927 2.16367838234 -2.56503981813 677.021368271 2.16367838234 -2.56603981813 677.252748977 2.16367838234 -2.56703981813 679.943080867 2.16367838234 -2.56803981813 680.844368464 2.16367838234 -2.56903981813 684.097740005 2.16367838234 -2.57003981813 686.878350223 2.16367838234 -2.57103981813 689.833359364 2.16367838234 -2.57203981813 691.871962669 2.16367838234 -2.57303981813 696.21013828 2.16367838234 -2.57403981813 699.982684865 2.16367838234 -2.57503981813 704.04049654 2.16367838234 -2.57603981813 708.026211458 2.16367838234 -2.57703981813 712.995426248 2.16367838234 -2.57803981813 718.194857367 2.16367838234 -2.57903981813 722.752763914 2.16367838234 -2.58003981813 727.966413417 2.16367838234 -2.58103981813 731.50353774 2.16367838234 -2.58203981813 736.710975095 2.16367838234 -2.58303981813 740.657926666 2.16367838234 -2.58403981813 744.261561255 2.16367838234 -2.58503981813 747.582550587 2.16367838234 -2.58603981813 749.012327157 2.16367838234 -2.58703981813 752.874754502 2.16367838234 -2.58803981813 755.210148686 2.16367838234 -2.58903981813 757.524033037 2.16367838234 -2.59003981813 759.197795224 2.16367838234 -2.59103981813 759.548711934 2.16367838234 -2.59203981813 762.163247005 2.16367838234 -2.59303981813 763.436325759 2.16367838234 -2.59403981813 764.437296864 2.16367838234 -2.59503981813 765.273456311 2.16367838234 -2.59603981813 764.990450765 2.16367838234 -2.59703981813 766.58942396 2.16367838234 -2.59803981813 766.59002907 2.16367838234 -2.59903981813 766.908908074 2.16367838234 -2.60003981813 766.62586698 2.16367838234 -2.60103981813 766.928637705 2.16367838234 -2.60203981813 768.117060349 2.16367838234 -2.60303981813 767.720879849 2.16367838234 -2.60403981813 770.870679288 2.16367838234 -2.60503981813 769.786188411 2.16367838234 -2.60603981813 772.435898154 2.16367838234 -2.60703981813 773.552500136 2.16367838234 -2.60803981813 774.923579254 2.16367838234 -2.60903981813 776.592861669 2.16367838234 -2.61003981813 777.417581091 2.16367838234 -2.61103981813 780.47190838 2.16367838234 -2.61203981813 782.087311711 2.16367838234 -2.61303981813 783.711068905 2.16367838234 -2.61403981813 786.766102564 2.16367838234 -2.61503981813 787.459511838 2.16367838234 -2.61603981813 790.38189979 2.16367838234 -2.61703981813 792.823667798 2.16367838234 -2.61803981813 795.174107244 2.16367838234 -2.61903981813 798.788265662 2.16367838234 -2.62003981813 799.432461084 2.16367838234 -2.62103981813 802.630808092 2.16367838234 -2.62203981813 804.870099551 2.16367838234 -2.62303981813 808.150987171 2.16367838234 -2.62403981813 808.740393311 2.16367838234 -2.62503981813 810.563624742 2.16367838234 -2.62603981813 813.626188695 2.16367838234 -2.62703981813 815.984331132 2.16367838234 -2.62803981813 817.419711474 2.16367838234 -2.62903981813 818.892073125 2.16367838234 -2.63003981813 821.763547125 2.16367838234 -2.63103981813 824.178446094 2.16367838234 -2.63203981813 824.708751786 2.16367838234 -2.63303981813 827.261688585 2.16367838234 -2.63403981813 827.643908597 2.16367838234 -2.63503981813 828.024646891 2.16367838234 -2.63603981813 831.162952379 2.16367838234 -2.63703981813 832.797546585 2.16367838234 -2.63803981813 834.569290868 2.16367838234 -2.63903981813 834.656434374 2.16367838234 -2.64003981813 836.721960667 2.16367838234 -2.64103981813 838.174456792 2.16367838234 -2.64203981813 839.705812431 2.16367838234 -2.64303981813 841.954192292 2.16367838234 -2.64403981813 841.961886061 2.16367838234 -2.64503981813 844.065927375 2.16367838234 -2.64603981813 844.664665524 2.16367838234 -2.64703981813 845.959401853 2.16367838234 -2.64803981813 846.8205113 2.16367838234 -2.64903981813 847.798657087 2.16367838234 -2.65003981813 849.605714111 2.16367838234 -2.65103981813 850.743730492 2.16367838234 -2.65203981813 850.693703552 2.16367838234 -2.65303981813 852.77459866 2.16367838234 -2.65403981813 852.625233279 2.16367838234 -2.65503981813 854.234388037 2.16367838234 -2.65603981813 854.993590392 2.16367838234 -2.65703981813 855.61461343 2.16367838234 -2.65803981813 855.890550184 2.16367838234 -2.65903981813 856.259540763 2.16367838234 -2.66003981813 855.520683899 2.16367838234 -2.66103981813 856.233160296 2.16367838234 -2.66203981813 855.566341999 2.16367838234 -2.66303981813 854.766195985 2.16367838234 -2.66403981813 855.907604563 2.16367838234 -2.66503981813 855.336903287 2.16367838234 -2.66603981813 854.046831668 2.16367838234 -2.66703981813 854.176182551 2.16367838234 -2.66803981813 854.525045055 2.16367838234 -2.66903981813 854.299896162 2.16367838234 -2.67003981813 853.493293127 2.16367838234 -2.67103981813 854.324235767 2.16367838234 -2.67203981813 854.275917798 2.16367838234 -2.67303981813 853.336093924 2.16367838234 -2.67403981813 854.763874494 2.16367838234 -2.67503981813 854.187185979 2.16367838234 -2.67603981813 855.08173654 2.16367838234 -2.67703981813 854.388474035 2.16367838234 -2.67803981813 854.630974348 2.16367838234 -2.67903981813 854.297551596 2.16367838234 -2.68003981813 853.105823673 2.16367838234 -2.68103981813 853.068570744 2.16367838234 -2.68203981813 852.455687656 2.16367838234 -2.68303981813 851.703640215 2.16367838234 -2.68403981813 851.004474477 0.186013776939 -2.68503981813 851.11921941 0.202198472023 -2.68603981813 851.328917264 0.179565769749 -2.68703981813 850.314485766 0.155575970186 -2.68803981813 849.305098419 0.150091451963 -2.68903981813 848.001209507 0.125714192454 -2.69003981813 846.40521647 0.0995282956877 -2.69103981813 844.818596172 0.101572474855 -2.69203981813 842.229163622 0.0795588801925 -2.69303981813 841.887671376 0.0437379186896 -2.69403981813 837.931634799 0.0437379186896 -2.69503981813 836.009076118 0.0437379186896 -2.69603981813 832.654330774 0.0437379186896 -2.69703981813 829.965871053 0.0437379186896 -2.69803981813 826.089700335 0.0437379186896 -2.69903981813 821.943670791 0.0437379186896 -2.70003981813 818.335888827 0.0437379186896 -2.70103981813 815.333225416 0.0437379186896 -2.70203981813 809.962637398 0.0437379186896 -2.70303981813 805.332220803 0.0437379186896 -2.70403981813 799.415808484 0.0437379186896 -2.70503981813 793.796129865 0.0437379186896 -2.70603981813 789.524262465 0.0437379186896 -2.70703981813 781.7484106 0.0437379186896 -2.70803981813 781.964235256 0.0437379186896 -2.70903981813 774.93907447 0.0437379186896 -2.71003981813 769.868293812 0.0437379186896 -2.71103981813 766.25768426 0.0437379186896 -2.71203981813 762.839922192 -0.138977027802 -2.71303981813 758.409994041 -0.80523709993 -2.71403981813 753.620633304 -0.80523709993 -2.71503981813 747.524849934 -0.650317016559 -2.71603981813 743.486991638 -0.295523940458 -2.71703981813 741.514370573 -0.295523940458 -2.71803981813 732.793816434 -0.295523940458 -2.71903981813 726.408356916 -0.295523940458 -2.72003981813 718.672875264 -0.295523940458 -2.72103981813 712.824163508 -0.295523940458 -2.72203981813 703.064792874 -0.295523940458 -2.72303981813 695.125665713 -0.295523940458 -2.72403981813 690.626765646 -0.295523940458 -2.72503981813 681.911725456 -0.295523940458 -2.72603981813 672.086156388 -0.295523940458 -2.72703981813 662.751586991 -0.295523940458 -2.72803981813 663.903461524 -0.295523940458 -2.72903981813 655.644301292 -0.295523940458 -2.73003981813 655.992161046 -0.295523940458 -2.73103981813 648.694107095 -0.295523940458 -2.73203981813 644.080617813 -0.295523940458 -2.73303981813 642.812114107 -0.295523940458 -2.73403981813 639.362745301 -0.295523940458 -2.73503981813 641.445056465 -0.295523940458 -2.73603981813 675.291842205 -0.295523940458 -2.73703981813 668.676811443 -0.295523940458 -2.73803981813 664.856027945 -0.295523940458 -2.73903981813 689.796545602 -0.295523940458 -2.74003981813 699.852178006 -0.295523940458 -2.74103981813 715.108458952 -0.295523940458 -2.74203981813 734.836546981 -0.295523940458 -2.74303981813 734.043040745 -0.295523940458 -2.74403981813 770.602320353 -0.295523940458 -2.74503981813 767.513390584 -0.295523940458 -2.74603981813 782.329398319 -0.295523940458 -2.74703981813 786.207547775 -0.295523940458 -2.74803981813 773.725392104 -0.295523940458 -2.74903981813 759.222088199 -0.295523940458 -2.75003981813 742.94745004 -0.295523940458 -2.75103981813 726.791473127 -0.295523940458 -2.75203981813 709.67580749 -0.585591241359 -2.75303981813 690.319164726 -0.609280212901 -2.75403981813 667.334713109 -0.624938967534 -2.75503981813 649.755955706 -0.640051731906 -2.75603981813 626.497750425 -0.658042409895 -2.75703981813 601.099346114 -0.669257200346 -2.75803981813 578.11922593 -0.688285497522 -2.75903981813 549.981755421 -0.688285497522 -2.76003981813 524.837123823 -0.688285497522 -2.76103981813 499.350151888 -0.688285497522 -2.76203981813 477.993809832 -0.688285497522 -2.76303981813 457.478256968 -0.688285497522 -2.76403981813 442.381669725 -0.688285497522 -2.76503981813 427.526435015 -0.688285497522 -2.76603981813 419.783562654 -0.688285497522 -2.76703981813 412.521987819 -0.688285497522 -2.76803981813 393.593912163 -0.688285497522 -2.76903981813 379.489213346 -0.688285497522 -2.77003981813 379.680608633 -0.688285497522 -2.77103981813 359.416855835 -0.688285497522 -2.77203981813 384.410405041 -0.688285497522 -2.77303981813 394.722947917 -0.688285497522 -2.77403981813 380.809243332 -0.688285497522 -2.77503981813 385.536250182 -0.688285497522 -2.77603981813 385.130274293 -0.688285497522 -2.77703981813 385.224127444 -0.688285497522 -2.77803981813 387.135143611 -0.688285497522 -2.77903981813 388.886029263 -0.688285497522 -2.78003981813 388.884218436 -0.688285497522 -2.78103981813 380.36304732 -0.688285497522 -2.78203981813 384.152364007 -0.688285497522 -2.78303981813 388.815459408 -0.688285497522 -2.78403981813 386.437848735 -0.688285497522 -2.78503981813 371.069445322 -0.688285497522 -2.78603981813 371.037400225 -0.688285497522 -2.78703981813 368.911799614 -0.688285497522 -2.78803981813 367.467844144 -0.688285497522 -2.78903981813 382.958556194 -0.688285497522 -2.79003981813 355.118666253 -0.688285497522 -2.79103981813 357.287613854 -0.688285497522 -2.79203981813 394.231374394 -0.688285497522 -2.79303981813 344.999592285 -0.688285497522 -2.79403981813 360.469806381 -0.688285497522 -2.79503981813 424.999953385 -0.688285497522 -2.79603981813 510.476465654 -0.688285497522 -2.79703981813 566.493270047 -0.688285497522 -2.79803981813 580.51793281 -0.688285497522 -2.79903981813 618.999152953 -0.688285497522 -2.80003981813 668.901932417 -0.688285497522 -2.80103981813 719.290175166 -0.688285497522 -2.80203981813 718.274100552 -0.688285497522 -2.80303981813 748.793993607 -0.688285497522 -2.80403981813 684.634651029 -0.688285497522 -2.80503981813 645.010611309 -0.688285497522 -2.80603981813 645.283516893 -0.688285497522 -2.80703981813 723.63679836 -0.688285497522 -2.80803981813 665.538960182 -0.688285497522 -2.80903981813 692.255061164 -0.688285497522 -2.81003981813 640.695817798 -0.688285497522 -2.81103981813 609.17377743 -0.688285497522 -2.81203981813 564.649686502 -0.688285497522 -2.81303981813 613.345181257 -0.688285497522 -2.81403981813 580.623765598 -0.688285497522 -2.81503981813 583.881401767 -0.688285497522 -2.81603981813 508.153452121 -0.688285497522 -2.81703981813 475.483132125 -0.688285497522 -2.81803981813 473.884175241 -0.688285497522 -2.81903981813 471.150296927 -0.688285497522 -2.82003981813 468.266328073 -0.688285497522 -2.82103981813 444.138331101 -0.688285497522 -2.82203981813 442.887761394 -0.688285497522 -2.82303981813 442.366504243 -0.688285497522 -2.82403981813 428.538025681 -0.688285497522 -2.82503981813 426.061926783 -0.688285497522 -2.82603981813 408.219166528 -0.688285497522 -2.82703981813 399.417771445 -0.688285497522 -2.82803981813 393.519559728 -0.688285497522 -2.82903981813 433.506287065 -0.688285497522 -2.83003981813 372.907753997 -0.688285497522 -2.83103981813 365.789849154 -0.688285497522 -2.83203981813 371.031633309 -0.688285497522 -2.83303981813 370.520229967 -0.688285497522 -2.83403981813 435.276745167 -0.688285497522 -2.83503981813 452.277914856 -0.688285497522 -2.83603981813 413.845769051 -0.688285497522 -2.83703981813 427.373214057 -0.688285497522 -2.83803981813 398.400280839 -0.688285497522 -2.83903981813 476.550790974 -0.688285497522 -2.84003981813 396.52024534 -0.688285497522 -2.84103981813 479.639222602 -0.688285497522 -2.84203981813 449.561640574 -0.688285497522 -2.84303981813 474.97828161 -0.688285497522 -2.84403981813 547.301654866 -0.688285497522 -2.84503981813 517.990899399 -0.688285497522 -2.84603981813 489.129206609 -0.688285497522 -2.84703981813 440.528171448 -0.688285497522 -2.84803981813 432.86999289 -0.688285497522 -2.84903981813 440.075317872 -0.688285497522 -2.85003981813 457.644295494 -0.688285497522 -2.85103981813 479.026537098 -0.688285497522 -2.85203981813 497.923510176 -1.2095149721 -2.85303981813 509.265932284 -1.22035852601 -2.85403981813 535.846303965 -1.24024496131 -2.85503981813 547.292862014 -1.21708658476 -2.85603981813 553.40655864 -1.26518345431 -2.85703981813 555.457866027 -1.25827234395 -2.85803981813 538.760007863 -1.25827234395 -2.85903981813 526.66431545 -1.25827234395 -2.86003981813 541.545320861 -1.25827234395 -2.86103981813 527.469916866 -1.25827234395 -2.86203981813 498.907188299 -1.25827234395 -2.86303981813 475.251979213 -1.25827234395 -2.86403981813 456.880499805 -1.25827234395 -2.86503981813 447.327471305 -1.25827234395 -2.86603981813 441.567572666 -1.25827234395 -2.86703981813 437.383991368 -1.25827234395 -2.86803981813 436.630134354 -1.25827234395 -2.86903981813 433.992874805 -1.25827234395 -2.87003981813 427.908990941 -1.25827234395 -2.87103981813 420.701096657 -1.25827234395 -2.87203981813 415.814942014 -1.25827234395 -2.87303981813 406.080279737 -1.25827234395 -2.87403981813 399.597445084 -1.25827234395 -2.87503981813 398.177357935 -1.25827234395 -2.87603981813 404.733294027 -1.25827234395 -2.87703981813 409.156535535 -1.25827234395 -2.87803981813 414.840653413 -1.25827234395 -2.87903981813 416.403690246 -1.25827234395 -2.88003981813 416.813373367 -1.25827234395 -2.88103981813 415.582991816 -1.25827234395 -2.88203981813 415.003229391 -1.25827234395 -2.88303981813 413.124562658 -1.25827234395 -2.88403981813 409.089763475 -1.25827234395 -2.88503981813 407.006878825 -1.25827234395 -2.88603981813 404.266274323 -1.25827234395 -2.88703981813 403.188845634 -1.25827234395 -2.88803981813 400.243555674 -1.25827234395 -2.88903981813 401.677153687 -1.25827234395 -2.89003981813 398.210352986 -1.25827234395 -2.89103981813 401.598725897 -1.25827234395 -2.89203981813 402.052321316 -1.25827234395 -2.89303981813 404.495395802 -1.25827234395 -2.89403981813 405.933282989 -1.25827234395 -2.89503981813 403.919280164 -1.25827234395 -2.89603981813 404.349493086 -1.25827234395 -2.89703981813 405.441130016 -1.25827234395 -2.89803981813 406.798282136 -1.25827234395 -2.89903981813 408.971295039 -1.25827234395 -2.90003981813 408.904554744 -1.25827234395 -2.90103981813 412.081389553 -1.25827234395 -2.90203981813 411.204262146 -1.25827234395 -2.90303981813 416.896943357 -1.25827234395 -2.90403981813 416.677480059 -1.25827234395 -2.90503981813 414.268228258 -1.25827234395 -2.90603981813 409.866418939 -1.25827234395 -2.90703981813 405.172449696 -1.25827234395 -2.90803981813 400.626089241 -2.42869361763 -2.90903981813 395.679639701 -2.44136185731 -2.91003981813 438.475546982 -2.43898947049 -2.91103981813 405.84775356 -2.47754792078 -2.91203981813 389.389563942 -2.47754792078 -2.91303981813 393.312711027 -2.47754792078 -2.91403981813 390.123190223 -2.47754792078 -2.91503981813 380.351899621 -2.47754792078 -2.91603981813 387.427134992 -2.47754792078 -2.91703981813 375.226985552 -2.47754792078 -2.91803981813 371.387701244 -2.47754792078 -2.91903981813 383.413717118 -2.47754792078 -2.92003981813 379.174091794 -2.47754792078 -2.92103981813 396.269938173 -2.47754792078 -2.92203981813 443.940483945 -2.47754792078 -2.92303981813 530.181662196 -2.47754792078 -2.92403981813 428.718100623 -2.47754792078 -2.92503981813 351.740389626 -2.47754792078 -2.92603981813 263.779262021 -2.47754792078 -2.92703981813 275.657181493 -2.47754792078 -2.92803981813 322.482800279 -2.47754792078 -2.92903981813 332.920604615 -2.47754792078 -2.93003981813 357.692471693 -2.47754792078 -2.93103981813 372.044854956 -2.47754792078 -2.93203981813 383.470633095 -2.47754792078 -2.93303981813 380.430982421 -2.47754792078 -2.93403981813 372.180905959 -2.47754792078 -2.93503981813 375.124995516 -2.47754792078 -2.93603981813 379.196075984 -2.47754792078 -2.93703981813 386.932238155 -2.47754792078 -2.93803981813 387.819347761 -2.47754792078 -2.93903981813 397.987685334 -2.47754792078 -2.94003981813 391.031546831 -2.47754792078 -2.94103981813 384.504072149 -2.47754792078 -2.94203981813 381.999062331 -2.47754792078 -2.94303981813 372.920418241 -2.47754792078 -2.94403981813 366.244096213 -2.47754792078 -2.94503981813 366.795772083 -2.47754792078 -2.94603981813 364.391132383 -2.47754792078 -2.94703981813 360.543956928 -2.47754792078 -2.94803981813 353.166661532 -2.47754792078 -2.94903981813 342.614813236 -2.47754792078 -2.95003981813 342.382504683 -2.47754792078 -2.95103981813 338.392573854 -2.47754792078 -2.95203981813 336.305550126 -2.47754792078 -2.95303981813 330.881562784 -2.47754792078 -2.95403981813 328.158369486 -2.47754792078 -2.95503981813 325.387288533 -2.47754792078 -2.95603981813 319.842942135 -2.47754792078 -2.95703981813 319.973956237 -2.47754792078 -2.95803981813 314.83090736 -2.47754792078 -2.95903981813 315.230358517 -2.47754792078 -2.96003981813 314.558766417 -2.47754792078 -2.96103981813 312.440189541 -2.47754792078 -2.96203981813 310.280604833 -2.47754792078 -2.96303981813 310.688498721 -2.47754792078 -2.96403981813 309.012985814 -2.47754792078 -2.96503981813 310.843183002 -2.47754792078 -2.96603981813 309.828140929 -2.47754792078 -2.96703981813 309.377059136 -2.47754792078 -2.96803981813 308.536733705 -2.47754792078 -2.96903981813 309.562997843 -2.47754792078 -2.97003981813 310.154631788 -2.47754792078 -2.97103981813 312.286975891 -2.47754792078 -2.97203981813 315.957999148 -2.47754792078 -2.97303981813 314.228445777 -2.47754792078 -2.97403981813 320.719883663 -2.47754792078 -2.97503981813 320.674737918 -2.47754792078 -2.97603981813 320.445787879 -2.47754792078 -2.97703981813 319.321401942 -2.47754792078 -2.97803981813 316.123032611 -2.47754792078 -2.97903981813 346.069167003 -2.47754792078 -2.98003981813 485.503268331 -2.47754792078 -2.98103981813 428.792335388 -2.47754792078 -2.98203981813 344.044447094 -2.47754792078 -2.98303981813 310.487478238 -2.47754792078 -2.98403981813 296.444171336 -2.47754792078 -2.98503981813 294.537787197 -2.47754792078 -2.98603981813 301.13731918 -2.47754792078 -2.98703981813 333.189260181 -2.47754792078 -2.98803981813 334.592042136 -2.47754792078 -2.98903981813 326.368018012 -2.47754792078 -2.99003981813 317.107379104 -2.47754792078 -2.99103981813 321.176175897 -2.47754792078 -2.99203981813 332.221265818 -2.47754792078 -2.99303981813 316.207458024 -2.47754792078 -2.99403981813 299.442026395 -2.47754792078 -2.99503981813 290.481302617 -2.47754792078 -2.99603981813 289.671354115 -2.47754792078 -2.99703981813 285.264350765 -2.47754792078 -2.99803981813 280.837220816 -2.47754792078 -2.99903981813 273.009471329 -2.47754792078 -3.00003981813 276.350024403 -2.47754792078 -3.00103981813 273.55977776 -2.47754792078 -3.00203981813 277.48958632 -2.47754792078 -3.00303981813 275.826650286 -2.47754792078 -3.00403981813 279.611586964 -2.47754792078 -3.00503981813 283.739747034 -2.47754792078 -3.00603981813 287.797430811 -2.47754792078 -3.00703981813 281.903399842 -2.47754792078 -3.00803981813 284.850660193 -2.47754792078 -3.00903981813 286.085380308 -2.47754792078 -3.01003981813 293.59713245 -2.47754792078 -3.01103981813 288.912344518 -2.47754792078 -3.01203981813 281.566616144 -2.47754792078 -3.01303981813 273.077699566 -2.47754792078 -3.01403981813 264.755187888 -2.47754792078 -3.01503981813 255.290717635 -2.47754792078 -3.01603981813 247.42597602 -2.47754792078 -3.01703981813 240.608026356 -2.47754792078 -3.01803981813 237.278812726 -2.47754792078 -3.01903981813 227.703928151 -2.47754792078 -3.02003981813 219.470633398 -2.47754792078 -3.02103981813 216.012086504 -2.47754792078 -3.02203981813 213.059297959 -2.47754792078 -3.02303981813 209.900438536 -2.47754792078 -3.02403981813 209.271711667 -2.47754792078 -3.02503981813 223.572489365 -2.47754792078 -3.02603981813 226.012486591 -2.47754792078 -3.02703981813 226.864516249 -2.47754792078 -3.02803981813 227.972569739 -2.47754792078 -3.02903981813 229.543525487 -2.47754792078 -3.03003981813 229.45843328 -2.47754792078 -3.03103981813 251.56068622 -2.47754792078 -3.03203981813 233.104853004 -2.47754792078 -3.03303981813 236.958822739 -2.47754792078 -3.03403981813 234.017054711 -2.47754792078 -3.03503981813 248.395701974 -2.47754792078 -3.03603981813 254.848323789 -2.47754792078 -3.03703981813 251.957705785 -2.47754792078 -3.03803981813 244.189494112 -2.47754792078 -3.03903981813 235.930468431 -2.47754792078 -3.04003981813 229.279411576 -2.47754792078 -3.04103981813 224.641098151 -2.47754792078 -3.04203981813 223.66390578 -2.47754792078 -3.04303981813 226.659682147 -2.47754792078 -3.04403981813 231.063998362 -2.47754792078 -3.04503981813 235.56715967 -2.47754792078 -3.04603981813 237.91324042 -2.47754792078 -3.04703981813 236.285328658 -2.47754792078 -3.04803981813 235.425257329 -2.47754792078 -3.04903981813 235.790047075 -2.47754792078 -3.05003981813 228.477358597 -2.47754792078 -3.05103981813 223.799048784 -2.47754792078 -3.05203981813 223.405897605 -2.47754792078 -3.05303981813 223.156620037 -2.47754792078 -3.05403981813 250.165916249 -2.47754792078 -3.05503981813 251.698388842 -2.47754792078 -3.05603981813 241.867095124 -2.47754792078 -3.05703981813 233.708353408 -2.47754792078 -3.05803981813 227.627806245 -2.47754792078 -3.05903981813 221.258571322 -2.47754792078 -3.06003981813 217.172610464 -2.47754792078 -3.06103981813 214.347973334 -2.47754792078 -3.06203981813 215.29087087 -2.47754792078 -3.06303981813 211.58406926 -2.47754792078 -3.06403981813 204.615405255 -2.47754792078 -3.06503981813 199.161681513 -2.47754792078 -3.06603981813 187.698772286 -2.47754792078 -3.06703981813 176.569104759 -2.47754792078 -3.06803981813 166.028996954 -2.47754792078 -3.06903981813 164.735637313 -2.47754792078 -3.07003981813 163.033309572 -2.47754792078 -3.07103981813 166.191824512 -2.47754792078 -3.07203981813 171.572436406 -2.47754792078 -3.07303981813 201.618582049 -2.47754792078 -3.07403981813 237.872256959 -2.47754792078 -3.07503981813 215.85789511 -2.47754792078 -3.07603981813 186.680694067 -2.47754792078 -3.07703981813 174.402286801 -2.47754792078 -3.07803981813 178.963727558 -2.47754792078 -3.07903981813 200.460817812 -2.47754792078 -3.08003981813 219.294502367 -2.47754792078 -3.08103981813 220.145373113 -2.47754792078 -3.08203981813 210.03469418 -2.47754792078 -3.08303981813 199.239341074 -2.47754792078 -3.08403981813 190.786235825 -2.47754792078 -3.08503981813 188.993108649 -2.47754792078 -3.08603981813 191.838438892 -2.47754792078 -3.08703981813 196.010541096 -2.47754792078 -3.08803981813 219.797563201 -2.47754792078 -3.08903981813 225.806382471 -2.47754792078 -3.09003981813 218.649290316 -2.47754792078 -3.09103981813 208.1110007 -2.47754792078 -3.09203981813 195.222445288 -2.47754792078 -3.09303981813 186.277416661 -2.47754792078 -3.09403981813 161.880233125 -2.47754792078 -3.09503981813 156.253656418 -2.47754792078 -3.09603981813 158.96304816 -2.47754792078 -3.09703981813 169.706585783 -2.47754792078 -3.09803981813 147.116780365 -2.47754792078 -3.09903981813 131.173485015 -2.47754792078 -3.10003981813 125.67605569 -2.47754792078 -3.10103981813 148.134472977 -2.47754792078 -3.10203981813 138.700770434 -2.47754792078 -3.10303981813 130.813810402 -2.47754792078 -3.10403981813 132.115881194 -2.47754792078 -3.10503981813 122.413284428 -2.47754792078 -3.10603981813 113.209439295 -2.47754792078 -3.10703981813 112.963327482 -2.47754792078 -3.10803981813 104.926383324 -2.47754792078 -3.10903981813 110.885668194 -2.47754792078 -3.11003981813 112.91270899 -2.47754792078 -3.11103981813 111.866536093 -2.47754792078 -3.11203981813 115.479262004 -2.47754792078 -3.11303981813 110.062223919 -2.47754792078 -3.11403981813 115.428024387 -2.47754792078 -3.11503981813 114.373242383 -2.47754792078 -3.11603981813 108.306748706 -2.47754792078 -3.11703981813 101.021686334 -2.47754792078 -3.11803981813 96.7503136865 -2.47754792078 -3.11903981813 93.5524075899 -2.47754792078 -3.12003981813 91.1548821459 -2.47754792078 -3.12103981813 91.0722751744 -2.47754792078 -3.12203981813 90.8143132738 -2.47754792078 -3.12303981813 90.6278256387 -2.47754792078 -3.12403981813 90.5878606093 -2.47754792078 -3.12503981813 92.5737578673 -2.47754792078 -3.12603981813 93.5361344925 -2.47754792078 -3.12703981813 112.662845006 -2.47754792078 -3.12803981813 121.308615568 -2.47754792078 -3.12903981813 108.041851419 -2.47754792078 -3.13003981813 99.5759438302 -2.47754792078 -3.13103981813 94.2997181669 -2.47754792078 -3.13203981813 91.9893221621 -2.47754792078 -3.13303981813 105.186265925 -2.47754792078 -3.13403981813 111.094534662 -2.47754792078 -3.13503981813 108.981453231 -2.47754792078 -3.13603981813 104.821446204 -2.47754792078 -3.13703981813 98.9568139005 -2.47754792078 -3.13803981813 90.1733364805 -2.47754792078 -3.13903981813 88.6899953834 -2.47754792078 -3.14003981813 75.4813422993 -2.47754792078 -3.14103981813 72.16943701 -2.47754792078 -3.14203981813 68.7697411598 -2.47754792078 -3.14303981813 69.9866815551 -2.47754792078 -3.14403981813 70.1223974193 -2.47754792078 -3.14503981813 69.3290653493 -2.47754792078 -3.14603981813 68.3448520999 -2.47754792078 -3.14703981813 67.8417995162 -2.47754792078 -3.14803981813 66.3359414456 -2.47754792078 -3.14903981813 64.5210541516 -2.47754792078 -3.15003981813 64.5217301983 -2.47754792078 -3.15103981813 60.3668512852 -2.47754792078 -3.15203981813 59.4404672313 -2.47754792078 -3.15303981813 60.1551119158 -2.47754792078 -3.15403981813 52.854476394 -2.47754792078 -3.15503981813 43.6128130662 -2.47754792078 -3.15603981813 28.6430412027 -2.47754792078 -3.15703981813 17.2308016284 -2.47754792078 -3.15803981813 14.2172284243 -2.47754792078 -3.15903981813 10.8857216924 -2.47754792078 -3.16003981813 45.2043877018 -2.47754792078 -3.16103981813 50.5847328038 -2.47754792078 -3.16203981813 50.3558178198 -2.47754792078 -3.16303981813 27.865363119 -2.47754792078 -3.16403981813 14.199377714 -2.47754792078 -3.16503981813 7.47561485327 -2.47754792078 -3.16603981813 35.4042849516 -2.47754792078 -3.16703981813 23.254290235 -2.47754792078 -3.16803981813 9.37117158487 -2.47754792078 -3.16903981813 25.2805394388 -2.47754792078 -3.17003981813 15.7517213262 -2.47754792078 -3.17103981813 13.8032891507 -2.47754792078 -3.17203981813 43.0304150747 -2.47754792078 -3.17303981813 19.3478977077 -2.47754792078 -3.17403981813 34.1719332239 -2.47754792078 -3.17503981813 34.9192042286 -2.47754792078 -3.17603981813 41.4796659983 -2.47754792078 -3.17703981813 44.324928328 -2.47754792078 -3.17803981813 41.4303829501 -2.47754792078 -3.17903981813 32.8874500999 -2.47754792078 -3.18003981813 21.9376054489 -2.47754792078 -3.18103981813 12.0292015197 -2.47754792078 -3.18203981813 3.51290785169 -2.47754792078 -3.18303981813 -36.9814376261 -2.47754792078 -3.18403981813 -44.5329847976 -2.47754792078 -3.18503981813 -42.3679831733 -2.47754792078 -3.18603981813 -17.0582093003 -2.47754792078 -3.18703981813 -13.293289333 -2.47754792078 -3.18803981813 -18.0887276451 -2.47754792078 -3.18903981813 -20.5206381215 -2.47754792078 -3.19003981813 7.0502065866 -2.47754792078 -3.19103981813 2.26274850451 -2.47754792078 -3.19203981813 -7.82982060553 -2.47754792078 -3.19303981813 -6.88373916252 -2.47754792078 -3.19403981813 -48.9070587633 -2.47754792078 -3.19503981813 -45.176884866 -2.47754792078 -3.19603981813 -36.4405598489 -2.47754792078 -3.19703981813 -36.8527352229 -2.47754792078 -3.19803981813 -39.5965920422 -2.47754792078 -3.19903981813 -38.9178941544 -2.47754792078 -3.20003981813 -79.212634214 -2.47754792078 -3.20103981813 -83.6150496961 -2.47754792078 -3.20203981813 -49.158748356 -2.47754792078 -3.20303981813 -58.639023386 -2.47754792078 -3.20403981813 -68.1674062429 -2.47754792078 -3.20503981813 -29.0432015435 -2.47754792078 -3.20603981813 -26.1751015263 -2.47754792078 -3.20703981813 -37.3654989733 -2.47754792078 -3.20803981813 -16.8424066286 -2.47754792078 -3.20903981813 -29.350143067 -2.47754792078 -3.21003981813 -26.3822567589 -2.47754792078 -3.21103981813 -26.3822567589 -2.47754792078 -3.21203981813 -26.3822567589 -2.47754792078 -3.21303981813 -26.3822567589 -2.47754792078 -3.21403981813 -26.3822567589 -2.47754792078 -3.21503981813 -26.3822567589 -2.47754792078 -3.21603981813 -26.3822567589 -2.47754792078 -3.21703981813 -26.3822567589 -2.47754792078 -3.21803981813 -26.3822567589 -2.47754792078 -3.21903981813 -26.3822567589 -2.47754792078 -3.22003981813 -26.3822567589 -2.47754792078 -3.22103981813 -26.3822567589 -2.47754792078 -3.22203981813 -26.3822567589 -2.47754792078 -3.22303981813 -26.3822567589 -2.47754792078 -3.22403981813 -26.3822567589 -2.47754792078 -3.22503981813 -26.3822567589 -2.47754792078 -3.22603981813 -26.3822567589 -2.47754792078 -3.22703981813 -26.3822567589 -2.47754792078 -3.22803981813 -26.3822567589 -2.47754792078 -3.22903981813 -26.3822567589 -2.47754792078 -3.23003981813 -26.3822567589 -2.47754792078 -3.23103981813 -26.3822567589 -2.47754792078 -3.23203981813 -26.3822567589 -2.47754792078 -3.23303981813 -26.3822567589 -2.47754792078 -3.23403981813 -26.3822567589 -2.47754792078 -3.23503981813 -26.3822567589 -2.47754792078 -3.23603981813 -26.3822567589 -2.47754792078 -3.23703981813 -26.3822567589 -2.47754792078 -3.23803981813 -26.3822567589 -2.47754792078 -3.23903981813 -26.3822567589 -2.47754792078 -3.24003981813 -26.3822567589 -2.47754792078 -3.24103981813 -26.3822567589 -2.47754792078 -3.24203981813 -26.3822567589 -2.47754792078 -3.24303981813 -26.3822567589 -2.47754792078 -3.24403981813 -26.3822567589 -2.47754792078 -3.24503981813 -26.3822567589 -2.47754792078 -3.24603981813 -26.3822567589 -2.47754792078 -3.24703981813 -26.3822567589 -2.47754792078 -3.24803981813 -26.3822567589 -2.47754792078 -3.24903981813 -26.3822567589 -2.47754792078 -3.25003981813 -26.3822567589 -2.47754792078 -3.25103981813 -26.3822567589 -2.47754792078 -3.25203981813 -26.3822567589 -2.47754792078 -3.25303981813 -26.3822567589 -2.47754792078 -3.25403981813 -26.3822567589 -2.47754792078 -3.25503981813 -26.3822567589 -2.47754792078 -3.25603981813 -26.3822567589 -2.47754792078 -3.25703981813 -26.3822567589 -2.47754792078 -3.25803981813 -26.3822567589 -2.47754792078 -3.25903981813 -26.3822567589 -2.47754792078 -3.26003981813 -26.3822567589 -2.47754792078 -3.26103981813 -26.3822567589 -2.47754792078 -3.26203981813 -26.3822567589 -2.47754792078 -3.26303981813 -26.3822567589 -2.47754792078 -3.26403981813 -26.3822567589 -2.47754792078 -3.26503981813 -26.3822567589 -2.47754792078 -3.26603981813 -26.3822567589 -2.47754792078 -3.26703981813 -26.3822567589 -2.47754792078 -3.26803981813 -26.3822567589 -2.47754792078 -3.26903981813 -26.3822567589 -2.47754792078 -3.27003981813 -26.3822567589 -2.47754792078 -3.27103981813 -26.3822567589 -2.47754792078 -3.27203981813 -26.3822567589 -2.47754792078 -3.27303981813 -26.3822567589 -2.47754792078 -3.27403981813 -26.3822567589 -2.47754792078 -3.27503981813 -26.3822567589 -2.47754792078 -3.27603981813 -26.3822567589 -2.47754792078 -3.27703981813 -26.3822567589 -2.47754792078 -3.27803981813 -26.3822567589 -2.47754792078 -3.27903981813 -26.3822567589 -2.47754792078 -3.28003981813 -26.3822567589 -2.47754792078 -3.28103981813 -26.3822567589 -2.47754792078 -3.28203981813 -26.3822567589 -2.47754792078 -3.28303981813 -26.3822567589 -2.47754792078 -3.28403981813 -26.3822567589 -2.47754792078 -3.28503981813 -26.3822567589 -2.47754792078 -3.28603981813 -26.3822567589 -2.47754792078 -3.28703981813 -26.3822567589 -2.47754792078 -3.28803981813 -26.3822567589 -2.47754792078 -3.28903981813 -26.3822567589 -2.47754792078 -3.29003981813 -26.3822567589 -2.47754792078 -3.29103981813 -26.3822567589 -2.47754792078 -3.29203981813 -26.3822567589 -2.47754792078 -3.29303981813 -26.3822567589 -2.47754792078 -3.29403981813 -26.3822567589 -2.47754792078 -3.29503981813 -26.3822567589 -2.47754792078 -3.29603981813 -26.3822567589 -2.47754792078 -3.29703981813 -26.3822567589 -2.47754792078 -3.29803981813 -26.3822567589 -2.47754792078 -3.29903981813 -26.3822567589 -2.47754792078 -3.30003981813 -26.3822567589 -2.47754792078 -3.30103981813 -26.3822567589 -2.47754792078 -3.30203981813 -26.3822567589 -2.47754792078 -3.30303981813 -26.3822567589 -2.47754792078 -3.30403981813 -26.3822567589 -2.47754792078 -3.30503981813 -26.3822567589 -2.47754792078 -3.30603981813 -26.3822567589 -2.47754792078 -3.30703981813 -26.3822567589 -2.47754792078 -3.30803981813 -26.3822567589 -2.47754792078 -3.30903981813 -26.3822567589 -2.47754792078 -3.31003981813 -26.3822567589 -2.47754792078 -3.31103981813 -26.3822567589 -2.47754792078 -3.31203981813 -26.3822567589 -2.47754792078 -3.31303981813 -26.3822567589 -2.47754792078 -3.31403981813 -26.3822567589 -2.47754792078 -3.31503981813 -26.3822567589 -2.47754792078 -3.31603981813 -26.3822567589 -2.47754792078 -3.31703981813 -26.3822567589 -2.47754792078 -3.31803981813 -26.3822567589 -2.47754792078 -3.31903981813 -26.3822567589 -2.47754792078 -3.32003981813 -26.3822567589 -2.47754792078 -3.32103981813 -26.3822567589 -2.47754792078 -3.32203981813 -26.3822567589 -2.47754792078 -3.32303981813 -26.3822567589 -2.47754792078 -3.32403981813 -26.3822567589 -2.47754792078 -3.32503981813 -26.3822567589 -2.47754792078 -3.32603981813 -26.3822567589 -2.47754792078 -3.32703981813 -26.3822567589 -2.47754792078 -3.32803981813 -26.3822567589 -2.47754792078 -3.32903981813 -26.3822567589 -2.47754792078 -3.33003981813 -26.3822567589 -2.47754792078 -3.33103981813 -26.3822567589 -2.47754792078 -3.33203981813 -26.3822567589 -2.47754792078 -3.33303981813 -26.3822567589 -2.47754792078 -3.33403981813 -26.3822567589 -2.47754792078 -3.33503981813 -26.3822567589 -2.47754792078 -3.33603981813 -26.3822567589 -2.47754792078 -3.33703981813 -26.3822567589 -2.47754792078 -3.33803981813 -26.3822567589 -2.47754792078 -3.33903981813 -26.3822567589 -2.47754792078 -3.34003981813 -26.3822567589 -2.47754792078 -3.34103981813 -26.3822567589 -2.47754792078 -3.34203981813 -26.3822567589 -2.47754792078 -3.34303981813 -26.3822567589 -2.47754792078 -3.34403981813 -26.3822567589 -2.47754792078 -3.34503981813 -26.3822567589 -2.47754792078 -3.34603981813 -26.3822567589 -2.47754792078 -3.34703981813 -26.3822567589 -2.47754792078 -3.34803981813 -26.3822567589 -2.47754792078 -3.34903981813 -26.3822567589 -2.47754792078 -3.35003981813 -26.3822567589 -2.47754792078 -3.35103981813 -26.3822567589 -2.47754792078 -3.35203981813 -26.3822567589 -2.47754792078 -3.35303981813 -26.3822567589 -2.47754792078 -3.35403981813 -26.3822567589 -2.47754792078 -3.35503981813 -26.3822567589 -2.47754792078 -3.35603981813 -26.3822567589 -2.47754792078 -3.35703981813 -26.3822567589 -2.47754792078 -3.35803981813 -26.3822567589 -2.47754792078 -3.35903981813 -26.3822567589 -2.47754792078 -3.36003981813 -26.3822567589 -2.47754792078 -3.36103981813 -26.3822567589 -2.47754792078 -3.36203981813 -26.3822567589 -2.47754792078 -3.36303981813 -26.3822567589 -2.47754792078 -3.36403981813 -26.3822567589 -2.47754792078 -3.36503981813 -26.3822567589 -2.47754792078 -3.36603981813 -26.3822567589 -2.47754792078 -3.36703981813 -26.3822567589 -2.47754792078 -3.36803981813 -26.3822567589 -2.47754792078 -3.36903981813 -26.3822567589 -2.47754792078 -3.37003981813 -26.3822567589 -2.47754792078 -3.37103981813 -26.3822567589 -2.47754792078 -3.37203981813 -26.3822567589 -2.47754792078 -3.37303981813 -26.3822567589 -2.47754792078 -3.37403981813 -26.3822567589 -2.47754792078 -3.37503981813 -26.3822567589 -2.47754792078 -3.37603981813 -26.3822567589 -2.47754792078 -3.37703981813 -26.3822567589 -2.47754792078 -3.37803981813 -26.3822567589 -2.47754792078 -3.37903981813 -26.3822567589 -2.47754792078 -3.38003981813 -26.3822567589 -2.47754792078 -3.38103981813 -26.3822567589 -2.47754792078 -3.38203981813 -26.3822567589 -2.47754792078 -3.38303981813 -26.3822567589 -2.47754792078 -3.38403981813 -26.3822567589 -2.47754792078 -3.38503981813 -26.3822567589 -2.47754792078 -3.38603981813 -26.3822567589 -2.47754792078 -3.38703981813 -26.3822567589 -2.47754792078 -3.38803981813 -26.3822567589 -2.47754792078 -3.38903981813 -26.3822567589 -2.47754792078 -3.39003981813 -26.3822567589 -2.47754792078 -3.39103981813 -26.3822567589 -2.47754792078 -3.39203981813 -26.3822567589 -2.47754792078 -3.39303981813 -26.3822567589 -2.47754792078 -3.39403981813 -26.3822567589 -2.47754792078 -3.39503981813 -26.3822567589 -2.47754792078 -3.39603981813 -26.3822567589 -2.47754792078 -3.39703981813 -26.3822567589 -2.47754792078 -3.39803981813 -26.3822567589 -2.47754792078 -3.39903981813 -26.3822567589 -2.47754792078 -3.40003981813 -26.3822567589 -2.47754792078 -3.40103981813 -26.3822567589 -2.47754792078 -3.40203981813 -26.3822567589 -2.47754792078 -3.40303981813 -26.3822567589 -2.47754792078 -3.40403981813 -26.3822567589 -2.47754792078 -3.40503981813 -26.3822567589 -2.47754792078 -3.40603981813 -26.3822567589 -2.47754792078 -3.40703981813 -26.3822567589 -2.47754792078 -3.40803981813 -26.3822567589 -2.47754792078 -3.40903981813 -26.3822567589 -2.47754792078 -3.41003981813 -26.3822567589 -2.47754792078 -3.41103981813 -26.3822567589 -2.47754792078 -3.41203981813 -26.3822567589 -2.47754792078 -3.41303981813 -26.3822567589 -2.47754792078 -3.41403981813 -26.3822567589 -2.47754792078 -3.41503981813 -26.3822567589 -2.47754792078 -3.41603981813 -26.3822567589 -2.47754792078 -3.41703981813 -26.3822567589 -2.47754792078 -3.41803981813 -26.3822567589 -2.47754792078 -3.41903981813 -26.3822567589 -2.47754792078 -3.42003981813 -26.3822567589 -2.47754792078 -3.42103981813 -26.3822567589 -2.47754792078 -3.42203981813 -26.3822567589 -2.47754792078 -3.42303981813 -26.3822567589 -2.47754792078 -3.42403981813 -26.3822567589 -2.47754792078 -3.42503981813 -26.3822567589 -2.47754792078 -3.42603981813 -26.3822567589 -2.47754792078 -3.42703981813 -26.3822567589 -2.47754792078 -3.42803981813 -26.3822567589 -2.47754792078 -3.42903981813 -26.3822567589 -2.47754792078 -3.43003981813 -26.3822567589 -2.47754792078 -3.43103981813 -26.3822567589 -2.47754792078 -3.43203981813 -26.3822567589 -2.47754792078 -3.43303981813 -26.3822567589 -2.47754792078 -3.43403981813 -26.3822567589 -2.47754792078 -3.43503981813 -26.3822567589 -2.47754792078 -3.43603981813 -26.3822567589 -2.47754792078 -3.43703981813 -26.3822567589 -2.47754792078 -3.43803981813 -26.3822567589 -2.47754792078 -3.43903981813 -26.3822567589 -2.47754792078 -3.44003981813 -26.3822567589 -2.47754792078 -3.44103981813 -26.3822567589 -2.47754792078 -3.44203981813 -26.3822567589 -2.47754792078 -3.44303981813 -26.3822567589 -2.47754792078 -3.44403981813 -26.3822567589 -2.47754792078 -3.44503981813 -26.3822567589 -2.47754792078 -3.44603981813 -26.3822567589 -2.47754792078 -3.44703981813 -26.3822567589 -2.47754792078 -3.44803981813 -26.3822567589 -2.47754792078 -3.44903981813 -26.3822567589 -2.47754792078 -3.45003981813 -26.3822567589 -2.47754792078 -3.45103981813 -26.3822567589 -2.47754792078 -3.45203981813 -26.3822567589 -2.47754792078 -3.45303981813 -26.3822567589 -2.47754792078 -3.45403981813 -26.3822567589 -2.47754792078 -3.45503981813 -26.3822567589 -2.47754792078 -3.45603981813 -26.3822567589 -2.47754792078 -3.45703981813 -26.3822567589 -2.47754792078 -3.45803981813 -26.3822567589 -2.47754792078 -3.45903981813 -26.3822567589 -2.47754792078 -3.46003981813 -26.3822567589 -2.47754792078 -3.46103981813 -26.3822567589 -2.47754792078 -3.46203981813 -26.3822567589 -2.47754792078 -3.46303981813 -26.3822567589 -2.47754792078 -3.46403981813 -26.3822567589 -2.47754792078 -3.46503981813 -26.3822567589 -2.47754792078 -3.46603981813 -26.3822567589 -2.47754792078 -3.46703981813 -26.3822567589 -2.47754792078 -3.46803981813 -26.3822567589 -2.47754792078 -3.46903981813 -26.3822567589 -2.47754792078 -3.47003981813 -26.3822567589 -2.47754792078 -3.47103981813 -26.3822567589 -2.47754792078 -3.47203981813 -26.3822567589 -2.47754792078 -3.47303981813 -26.3822567589 -2.47754792078 -3.47403981813 -26.3822567589 -2.47754792078 -3.47503981813 -26.3822567589 -2.47754792078 -3.47603981813 -26.3822567589 -2.47754792078 -3.47703981813 -26.3822567589 -2.47754792078 -3.47803981813 -26.3822567589 -2.47754792078 -3.47903981813 -26.3822567589 -2.47754792078 -3.48003981813 -26.3822567589 -2.47754792078 -3.48103981813 -26.3822567589 -2.47754792078 -3.48203981813 -26.3822567589 -2.47754792078 -3.48303981813 -26.3822567589 -2.47754792078 -3.48403981813 -26.3822567589 -2.47754792078 -3.48503981813 -26.3822567589 -2.47754792078 -3.48603981813 -26.3822567589 -2.47754792078 -3.48703981813 -26.3822567589 -2.47754792078 -3.48803981813 -26.3822567589 -2.47754792078 -3.48903981813 -26.3822567589 -2.47754792078 -3.49003981813 -26.3822567589 -2.47754792078 -3.49103981813 -26.3822567589 -2.47754792078 -3.49203981813 -26.3822567589 -2.47754792078 -3.49303981813 -26.3822567589 -2.47754792078 -3.49403981813 -26.3822567589 -2.47754792078 -3.49503981813 -26.3822567589 -2.47754792078 -3.49603981813 -26.3822567589 -2.47754792078 -3.49703981813 -26.3822567589 -2.47754792078 -3.49803981813 -26.3822567589 -2.47754792078 -3.49903981813 -26.3822567589 -2.47754792078 -3.50003981813 -26.3822567589 -2.47754792078 -3.50103981813 -26.3822567589 -2.47754792078 -3.50203981813 -26.3822567589 -2.47754792078 -3.50303981813 -26.3822567589 -2.47754792078 -3.50403981813 -26.3822567589 -2.47754792078 -3.50503981813 -26.3822567589 -2.47754792078 -3.50603981813 -26.3822567589 -2.47754792078 -3.50703981813 -26.3822567589 -2.47754792078 -3.50803981813 -26.3822567589 -2.47754792078 -3.50903981813 -26.3822567589 -2.47754792078 -3.51003981813 -26.3822567589 -2.47754792078 -3.51103981813 -26.3822567589 -2.47754792078 -3.51203981813 -26.3822567589 -2.47754792078 -3.51303981813 -26.3822567589 -2.47754792078 -3.51403981813 -26.3822567589 -2.47754792078 -3.51503981813 -26.3822567589 -2.47754792078 -3.51603981813 -26.3822567589 -2.47754792078 -3.51703981813 -26.3822567589 -2.47754792078 -3.51803981813 -26.3822567589 -2.47754792078 -3.51903981813 -26.3822567589 -2.47754792078 -3.52003981813 -26.3822567589 -2.47754792078 -3.52103981813 -26.3822567589 -2.47754792078 -3.52203981813 -26.3822567589 -2.47754792078 -3.52303981813 -26.3822567589 -2.47754792078 -3.52403981813 -26.3822567589 -2.47754792078 -3.52503981813 -26.3822567589 -2.47754792078 -3.52603981813 -26.3822567589 -2.47754792078 -3.52703981813 -26.3822567589 -2.47754792078 -3.52803981813 -26.3822567589 -2.47754792078 -3.52903981813 -26.3822567589 -2.47754792078 -3.53003981813 -26.3822567589 -2.47754792078 -3.53103981813 -26.3822567589 -2.47754792078 -3.53203981813 -26.3822567589 -2.47754792078 -3.53303981813 -26.3822567589 -2.47754792078 -3.53403981813 -26.3822567589 -2.47754792078 -3.53503981813 -26.3822567589 -2.47754792078 -3.53603981813 -26.3822567589 -2.47754792078 -3.53703981813 -26.3822567589 -2.47754792078 -3.53803981813 -26.3822567589 -2.47754792078 -3.53903981813 -26.3822567589 -2.47754792078 -3.54003981813 -26.3822567589 -2.47754792078 -3.54103981813 -26.3822567589 -2.47754792078 -3.54203981813 -26.3822567589 -2.47754792078 -3.54303981813 -26.3822567589 -2.47754792078 -3.54403981813 -26.3822567589 -2.47754792078 -3.54503981813 -26.3822567589 -2.47754792078 -3.54603981813 -26.3822567589 -2.47754792078 -3.54703981813 -26.3822567589 -2.47754792078 -3.54803981813 -26.3822567589 -2.47754792078 -3.54903981813 -26.3822567589 -2.47754792078 -3.55003981813 -26.3822567589 -2.47754792078 -3.55103981813 -26.3822567589 -2.47754792078 -3.55203981813 -26.3822567589 -2.47754792078 -3.55303981813 -26.3822567589 -2.47754792078 -3.55403981813 -26.3822567589 -2.47754792078 -3.55503981813 -26.3822567589 -2.47754792078 -3.55603981813 -26.3822567589 -2.47754792078 -3.55703981813 -26.3822567589 -2.47754792078 -3.55803981813 -26.3822567589 -2.47754792078 -3.55903981813 -26.3822567589 -2.47754792078 -3.56003981813 -26.3822567589 -2.47754792078 -3.56103981813 -26.3822567589 -2.47754792078 -3.56203981813 -26.3822567589 -2.47754792078 -3.56303981813 -26.3822567589 -2.47754792078 -3.56403981813 -26.3822567589 -2.47754792078 -3.56503981813 -26.3822567589 -2.47754792078 -3.56603981813 -26.3822567589 -2.47754792078 -3.56703981813 -26.3822567589 -2.47754792078 -3.56803981813 -26.3822567589 -2.47754792078 -3.56903981813 -26.3822567589 -2.47754792078 -3.57003981813 -26.3822567589 -2.47754792078 -3.57103981813 -26.3822567589 -2.47754792078 -3.57203981813 -26.3822567589 -2.47754792078 -3.57303981813 -26.3822567589 -2.47754792078 -3.57403981813 -26.3822567589 -2.47754792078 -3.57503981813 -26.3822567589 -2.47754792078 -3.57603981813 -26.3822567589 -2.47754792078 -3.57703981813 -26.3822567589 -2.47754792078 -3.57803981813 -26.3822567589 -2.47754792078 -3.57903981813 -26.3822567589 -2.47754792078 -3.58003981813 -26.3822567589 -2.47754792078 -3.58103981813 -26.3822567589 -2.47754792078 -3.58203981813 -26.3822567589 -2.47754792078 -3.58303981813 -26.3822567589 -2.47754792078 -3.58403981813 -26.3822567589 -2.47754792078 -3.58503981813 -26.3822567589 -2.47754792078 -3.58603981813 -26.3822567589 -2.47754792078 -3.58703981813 -26.3822567589 -2.47754792078 -3.58803981813 -26.3822567589 -2.47754792078 -3.58903981813 -26.3822567589 -2.47754792078 -3.59003981813 -26.3822567589 -2.47754792078 -3.59103981813 -26.3822567589 -2.47754792078 -3.59203981813 -26.3822567589 -2.47754792078 -3.59303981813 -26.3822567589 -2.47754792078 -3.59403981813 -26.3822567589 -2.47754792078 -3.59503981813 -26.3822567589 -2.47754792078 -3.59603981813 -26.3822567589 -2.47754792078 -3.59703981813 -26.3822567589 -2.47754792078 -3.59803981813 -26.3822567589 -2.47754792078 -3.59903981813 -26.3822567589 -2.47754792078 -3.60003981813 -26.3822567589 -2.47754792078 -3.60103981813 -26.3822567589 -2.47754792078 -3.60203981813 -26.3822567589 -2.47754792078 -3.60303981813 -26.3822567589 -2.47754792078 -3.60403981813 -26.3822567589 -2.47754792078 -3.60503981813 -26.3822567589 -2.47754792078 -3.60603981813 -26.3822567589 -2.47754792078 -3.60703981813 -26.3822567589 -2.47754792078 -3.60803981813 -26.3822567589 -2.47754792078 -3.60903981813 -26.3822567589 -2.47754792078 -3.61003981813 -26.3822567589 -2.47754792078 -3.61103981813 -26.3822567589 -2.47754792078 -3.61203981813 -26.3822567589 -2.47754792078 -3.61303981813 -26.3822567589 -2.47754792078 -3.61403981813 -26.3822567589 -2.47754792078 -3.61503981813 -26.3822567589 -2.47754792078 -3.61603981813 -26.3822567589 -2.47754792078 -3.61703981813 -26.3822567589 -2.47754792078 -3.61803981813 -26.3822567589 -2.47754792078 -3.61903981813 -26.3822567589 -2.47754792078 -3.62003981813 -26.3822567589 -2.47754792078 -3.62103981813 -26.3822567589 -2.47754792078 -3.62203981813 -26.3822567589 -2.47754792078 -3.62303981813 -26.3822567589 -2.47754792078 -3.62403981813 -26.3822567589 -2.47754792078 -3.62503981813 -26.3822567589 -2.47754792078 -3.62603981813 -26.3822567589 -2.47754792078 -3.62703981813 -26.3822567589 -2.47754792078 -3.62803981813 -26.3822567589 -2.47754792078 -3.62903981813 -26.3822567589 -2.47754792078 -3.63003981813 -26.3822567589 -2.47754792078 -3.63103981813 -26.3822567589 -2.47754792078 -3.63203981813 -26.3822567589 -2.47754792078 -3.63303981813 -26.3822567589 -2.47754792078 -3.63403981813 -26.3822567589 -2.47754792078 -3.63503981813 -26.3822567589 -2.47754792078 -3.63603981813 -26.3822567589 -2.47754792078 -3.63703981813 -26.3822567589 -2.47754792078 -3.63803981813 -26.3822567589 -2.47754792078 -3.63903981813 -26.3822567589 -2.47754792078 -3.64003981813 -26.3822567589 -2.47754792078 -3.64103981813 -26.3822567589 -2.47754792078 -3.64203981813 -26.3822567589 -2.47754792078 -3.64303981813 -26.3822567589 -2.47754792078 -3.64403981813 -26.3822567589 -2.47754792078 -3.64503981813 -26.3822567589 -2.47754792078 -3.64603981813 -26.3822567589 -2.47754792078 -3.64703981813 -26.3822567589 -2.47754792078 -3.64803981813 -26.3822567589 -2.47754792078 -3.64903981813 -26.3822567589 -2.47754792078 -3.65003981813 -26.3822567589 -2.47754792078 -3.65103981813 -26.3822567589 -2.47754792078 -3.65203981813 -26.3822567589 -2.47754792078 -3.65303981813 -26.3822567589 -2.47754792078 -3.65403981813 -26.3822567589 -2.47754792078 -3.65503981813 -26.3822567589 -2.47754792078 -3.65603981813 -26.3822567589 -2.47754792078 -3.65703981813 -26.3822567589 -2.47754792078 -3.65803981813 -26.3822567589 -2.47754792078 -3.65903981813 -26.3822567589 -2.47754792078 -3.66003981813 -26.3822567589 -2.47754792078 -3.66103981813 -26.3822567589 -2.47754792078 -3.66203981813 -26.3822567589 -2.47754792078 -3.66303981813 -26.3822567589 -2.47754792078 -3.66403981813 -26.3822567589 -2.47754792078 -3.66503981813 -26.3822567589 -2.47754792078 -3.66603981813 -26.3822567589 -2.47754792078 -3.66703981813 -26.3822567589 -2.47754792078 -3.66803981813 -26.3822567589 -2.47754792078 -3.66903981813 -26.3822567589 -2.47754792078 -3.67003981813 -26.3822567589 -2.47754792078 -3.67103981813 -26.3822567589 -2.47754792078 -3.67203981813 -26.3822567589 -2.47754792078 -3.67303981813 -26.3822567589 -2.47754792078 -3.67403981813 -26.3822567589 -2.47754792078 -3.67503981813 -26.3822567589 -2.47754792078 -3.67603981813 -26.3822567589 -2.47754792078 -3.67703981813 -26.3822567589 -2.47754792078 -3.67803981813 -26.3822567589 -2.47754792078 -3.67903981813 -26.3822567589 -2.47754792078 -3.68003981813 -26.3822567589 -2.47754792078 -3.68103981813 -26.3822567589 -2.47754792078 -3.68203981813 -26.3822567589 -2.47754792078 -3.68303981813 -26.3822567589 -2.47754792078 -3.68403981813 -26.3822567589 -2.47754792078 -3.68503981813 -26.3822567589 -2.47754792078 -3.68603981813 -26.3822567589 -2.47754792078 -3.68703981813 -26.3822567589 -2.47754792078 -3.68803981813 -26.3822567589 -2.47754792078 -3.68903981813 -26.3822567589 -2.47754792078 -3.69003981813 -26.3822567589 -2.47754792078 -3.69103981813 -26.3822567589 -2.47754792078 -3.69203981813 -26.3822567589 -2.47754792078 -3.69303981813 -26.3822567589 -2.47754792078 -3.69403981813 -26.3822567589 -2.47754792078 -3.69503981813 -26.3822567589 -2.47754792078 -3.69603981813 -26.3822567589 -2.47754792078 -3.69703981813 -26.3822567589 -2.47754792078 -3.69803981813 -26.3822567589 -2.47754792078 -3.69903981813 -26.3822567589 -2.47754792078 -3.70003981813 -26.3822567589 -2.47754792078 -3.70103981813 -26.3822567589 -2.47754792078 -3.70203981813 -26.3822567589 -2.47754792078 -3.70303981813 -26.3822567589 -2.47754792078 -3.70403981813 -26.3822567589 -2.47754792078 -3.70503981813 -26.3822567589 -2.47754792078 -3.70603981813 -26.3822567589 -2.47754792078 -3.70703981813 -26.3822567589 -2.47754792078 -3.70803981813 -26.3822567589 -2.47754792078 -3.70903981813 -26.3822567589 -2.47754792078 -3.71003981813 -26.3822567589 -2.47754792078 -3.71103981813 -26.3822567589 -2.47754792078 -3.71203981813 -26.3822567589 -2.47754792078 -3.71303981813 -26.3822567589 -2.47754792078 -3.71403981813 -26.3822567589 -2.47754792078 -3.71503981813 -26.3822567589 -2.47754792078 -3.71603981813 -26.3822567589 -2.47754792078 -3.71703981813 -26.3822567589 -2.47754792078 -3.71803981813 -26.3822567589 -2.47754792078 -3.71903981813 -26.3822567589 -2.47754792078 -3.72003981813 -26.3822567589 -2.47754792078 -3.72103981813 -26.3822567589 -2.47754792078 -3.72203981813 -26.3822567589 -2.47754792078 -3.72303981813 -26.3822567589 -2.47754792078 -3.72403981813 -26.3822567589 -2.47754792078 -3.72503981813 -26.3822567589 -2.47754792078 -3.72603981813 -26.3822567589 -2.47754792078 -3.72703981813 -26.3822567589 -2.47754792078 -3.72803981813 -26.3822567589 -2.47754792078 -3.72903981813 -26.3822567589 -2.47754792078 -3.73003981813 -26.3822567589 -2.47754792078 -3.73103981813 -26.3822567589 -2.47754792078 -3.73203981813 -26.3822567589 -2.47754792078 -3.73303981813 -26.3822567589 -2.47754792078 -3.73403981813 -26.3822567589 -2.47754792078 -3.73503981813 -26.3822567589 -2.47754792078 -3.73603981813 -26.3822567589 -2.47754792078 -3.73703981813 -26.3822567589 -2.47754792078 -3.73803981813 -26.3822567589 -2.47754792078 -3.73903981813 -26.3822567589 -2.47754792078 -3.74003981813 -26.3822567589 -2.47754792078 -3.74103981813 -26.3822567589 -2.47754792078 -3.74203981813 -26.3822567589 -2.47754792078 -3.74303981813 -26.3822567589 -2.47754792078 -3.74403981813 -26.3822567589 -2.47754792078 -3.74503981813 -26.3822567589 -2.47754792078 -3.74603981813 -26.3822567589 -2.47754792078 -3.74703981813 -26.3822567589 -2.47754792078 -3.74803981813 -26.3822567589 -2.47754792078 -3.74903981813 -26.3822567589 -2.47754792078 -3.75003981813 -26.3822567589 -2.47754792078 -3.75103981813 -26.3822567589 -2.47754792078 -3.75203981813 -26.3822567589 -2.47754792078 -3.75303981813 -26.3822567589 -2.47754792078 -3.75403981813 -26.3822567589 -2.47754792078 -3.75503981813 -26.3822567589 -2.47754792078 -3.75603981813 -26.3822567589 -2.47754792078 -3.75703981813 -26.3822567589 -2.47754792078 -3.75803981813 -26.3822567589 -2.47754792078 -3.75903981813 -26.3822567589 -2.47754792078 -3.76003981813 -26.3822567589 -2.47754792078 -3.76103981813 -26.3822567589 -2.47754792078 -3.76203981813 -26.3822567589 -2.47754792078 -3.76303981813 -26.3822567589 -2.47754792078 -3.76403981813 -26.3822567589 -2.47754792078 -3.76503981813 -26.3822567589 -2.47754792078 -3.76603981813 -26.3822567589 -2.47754792078 -3.76703981813 -26.3822567589 -2.47754792078 -3.76803981813 -26.3822567589 -2.47754792078 -3.76903981813 -26.3822567589 -2.47754792078 -3.77003981813 -26.3822567589 -2.47754792078 -3.77103981813 -26.3822567589 -2.47754792078 -3.77203981813 -26.3822567589 -2.47754792078 -3.77303981813 -26.3822567589 -2.47754792078 -3.77403981813 -26.3822567589 -2.47754792078 -3.77503981813 -26.3822567589 -2.47754792078 -3.77603981813 -26.3822567589 -2.47754792078 -3.77703981813 -26.3822567589 -2.47754792078 -3.77803981813 -26.3822567589 -2.47754792078 -3.77903981813 -26.3822567589 -2.47754792078 -3.78003981813 -26.3822567589 -2.47754792078 -3.78103981813 -26.3822567589 -2.47754792078 -3.78203981813 -26.3822567589 -2.47754792078 -3.78303981813 -26.3822567589 -2.47754792078 -3.78403981813 -26.3822567589 -2.47754792078 -3.78503981813 -26.3822567589 -2.47754792078 -3.78603981813 -26.3822567589 -2.47754792078 -3.78703981813 -26.3822567589 -2.47754792078 -3.78803981813 -26.3822567589 -2.47754792078 -3.78903981813 -26.3822567589 -2.47754792078 -3.79003981813 -26.3822567589 -2.47754792078 -3.79103981813 -26.3822567589 -2.47754792078 -3.79203981813 -26.3822567589 -2.47754792078 -3.79303981813 -26.3822567589 -2.47754792078 -3.79403981813 -26.3822567589 -2.47754792078 -3.79503981813 -26.3822567589 -2.47754792078 -3.79603981813 -26.3822567589 -2.47754792078 -3.79703981813 -26.3822567589 -2.47754792078 -3.79803981813 -26.3822567589 -2.47754792078 -3.79903981813 -26.3822567589 -2.47754792078 -3.80003981813 -26.3822567589 -2.47754792078 -3.80103981813 -26.3822567589 -2.47754792078 -3.80203981813 -26.3822567589 -2.47754792078 -3.80303981813 -26.3822567589 -2.47754792078 -3.80403981813 -26.3822567589 -2.47754792078 -3.80503981813 -26.3822567589 -2.47754792078 -3.80603981813 -26.3822567589 -2.47754792078 -3.80703981813 -26.3822567589 -2.47754792078 -3.80803981813 -26.3822567589 -2.47754792078 -3.80903981813 -26.3822567589 -2.47754792078 -3.81003981813 -26.3822567589 -2.47754792078 -3.81103981813 -26.3822567589 -2.47754792078 -3.81203981813 -26.3822567589 -2.47754792078 -3.81303981813 -26.3822567589 -2.47754792078 -3.81403981813 -26.3822567589 -2.47754792078 -3.81503981813 -26.3822567589 -2.47754792078 -3.81603981813 -26.3822567589 -2.47754792078 -3.81703981813 -26.3822567589 -2.47754792078 -3.81803981813 -26.3822567589 -2.47754792078 -3.81903981813 -26.3822567589 -2.47754792078 -3.82003981813 -26.3822567589 -2.47754792078 -3.82103981813 -26.3822567589 -2.47754792078 -3.82203981813 -26.3822567589 -2.47754792078 -3.82303981813 -26.3822567589 -2.47754792078 -3.82403981813 -26.3822567589 -2.47754792078 -3.82503981813 -26.3822567589 -2.47754792078 -3.82603981813 -26.3822567589 -2.47754792078 -3.82703981813 -26.3822567589 -2.47754792078 -3.82803981813 -26.3822567589 -2.47754792078 -3.82903981813 -26.3822567589 -2.47754792078 -3.83003981813 -26.3822567589 -2.47754792078 -3.83103981813 -26.3822567589 -2.47754792078 -3.83203981813 -26.3822567589 -2.47754792078 -3.83303981813 -26.3822567589 -2.47754792078 -3.83403981813 -26.3822567589 -2.47754792078 -3.83503981813 -26.3822567589 -2.47754792078 -3.83603981813 -26.3822567589 -2.47754792078 -3.83703981813 -26.3822567589 -2.47754792078 -3.83803981813 -26.3822567589 -2.47754792078 -3.83903981813 -26.3822567589 -2.47754792078 -3.84003981813 -26.3822567589 -2.47754792078 -3.84103981813 -26.3822567589 -2.47754792078 -3.84203981813 -26.3822567589 -2.47754792078 -3.84303981813 -26.3822567589 -2.47754792078 -3.84403981813 -26.3822567589 -2.47754792078 -3.84503981813 -26.3822567589 -2.47754792078 -3.84603981813 -26.3822567589 -2.47754792078 -3.84703981813 -26.3822567589 -2.47754792078 -3.84803981813 -26.3822567589 -2.47754792078 -3.84903981813 -26.3822567589 -2.47754792078 -3.85003981813 -26.3822567589 -2.47754792078 -3.85103981813 -26.3822567589 -2.47754792078 -3.85203981813 -26.3822567589 -2.47754792078 -3.85303981813 -26.3822567589 -2.47754792078 -3.85403981813 -26.3822567589 -2.47754792078 -3.85503981813 -26.3822567589 -2.47754792078 -3.85603981813 -26.3822567589 -2.47754792078 -3.85703981813 -26.3822567589 -2.47754792078 -3.85803981813 -26.3822567589 -2.47754792078 -3.85903981813 -26.3822567589 -2.47754792078 -3.86003981813 -26.3822567589 -2.47754792078 -3.86103981813 -26.3822567589 -2.47754792078 -3.86203981813 -26.3822567589 -2.47754792078 -3.86303981813 -26.3822567589 -2.47754792078 -3.86403981813 -26.3822567589 -2.47754792078 -3.86503981813 -26.3822567589 -2.47754792078 -3.86603981813 -26.3822567589 -2.47754792078 -3.86703981813 -26.3822567589 -2.47754792078 -3.86803981813 -26.3822567589 -2.47754792078 -3.86903981813 -26.3822567589 -2.47754792078 -3.87003981813 -26.3822567589 -2.47754792078 -3.87103981813 -26.3822567589 -2.47754792078 -3.87203981813 -26.3822567589 -2.47754792078 -3.87303981813 -26.3822567589 -2.47754792078 -3.87403981813 -26.3822567589 -2.47754792078 -3.87503981813 -26.3822567589 -2.47754792078 -3.87603981813 -26.3822567589 -2.47754792078 -3.87703981813 -26.3822567589 -2.47754792078 -3.87803981813 -26.3822567589 -2.47754792078 -3.87903981813 -26.3822567589 -2.47754792078 -3.88003981813 -26.3822567589 -2.47754792078 -3.88103981813 -26.3822567589 -2.47754792078 -3.88203981813 -26.3822567589 -2.47754792078 -3.88303981813 -26.3822567589 -2.47754792078 -3.88403981813 -26.3822567589 -2.47754792078 -3.88503981813 -26.3822567589 -2.47754792078 -3.88603981813 -26.3822567589 -2.47754792078 -3.88703981813 -26.3822567589 -2.47754792078 -3.88803981813 -26.3822567589 -2.47754792078 -3.88903981813 -26.3822567589 -2.47754792078 -3.89003981813 -26.3822567589 -2.47754792078 -3.89103981813 -26.3822567589 -2.47754792078 -3.89203981813 -26.3822567589 -2.47754792078 -3.89303981813 -26.3822567589 -2.47754792078 -3.89403981813 -26.3822567589 -2.47754792078 -3.89503981813 -26.3822567589 -2.47754792078 -3.89603981813 -26.3822567589 -2.47754792078 -3.89703981813 -26.3822567589 -2.47754792078 -3.89803981813 -26.3822567589 -2.47754792078 -3.89903981813 -26.3822567589 -2.47754792078 -3.90003981813 -26.3822567589 -2.47754792078 -3.90103981813 -26.3822567589 -2.47754792078 -3.90203981813 -26.3822567589 -2.47754792078 -3.90303981813 -26.3822567589 -2.47754792078 -3.90403981813 -26.3822567589 -2.47754792078 -3.90503981813 -26.3822567589 -2.47754792078 -3.90603981813 -26.3822567589 -2.47754792078 -3.90703981813 -26.3822567589 -2.47754792078 -3.90803981813 -26.3822567589 -2.47754792078 -3.90903981813 -26.3822567589 -2.47754792078 -3.91003981813 -26.3822567589 -2.47754792078 -3.91103981813 -26.3822567589 -2.47754792078 -3.91203981813 -26.3822567589 -2.47754792078 -3.91303981813 -26.3822567589 -2.47754792078 -3.91403981813 -26.3822567589 -2.47754792078 -3.91503981813 -26.3822567589 -2.47754792078 -3.91603981813 -26.3822567589 -2.47754792078 -3.91703981813 -26.3822567589 -2.47754792078 -3.91803981813 -26.3822567589 -2.47754792078 -3.91903981813 -26.3822567589 -2.47754792078 -3.92003981813 -26.3822567589 -2.47754792078 -3.92103981813 -26.3822567589 -2.47754792078 -3.92203981813 -26.3822567589 -2.47754792078 -3.92303981813 -26.3822567589 -2.47754792078 -3.92403981813 -26.3822567589 -2.47754792078 -3.92503981813 -26.3822567589 -2.47754792078 -3.92603981813 -26.3822567589 -2.47754792078 -3.92703981813 -26.3822567589 -2.47754792078 -3.92803981813 -26.3822567589 -2.47754792078 -3.92903981813 -26.3822567589 -2.47754792078 -3.93003981813 -26.3822567589 -2.47754792078 -3.93103981813 -26.3822567589 -2.47754792078 -3.93203981813 -26.3822567589 -2.47754792078 -3.93303981813 -26.3822567589 -2.47754792078 -3.93403981813 -26.3822567589 -2.47754792078 -3.93503981813 -26.3822567589 -2.47754792078 -3.93603981813 -26.3822567589 -2.47754792078 -3.93703981813 -26.3822567589 -2.47754792078 -3.93803981813 -26.3822567589 -2.47754792078 -3.93903981813 -26.3822567589 -2.47754792078 -3.94003981813 -26.3822567589 -2.47754792078 -3.94103981813 -26.3822567589 -2.47754792078 -3.94203981813 -26.3822567589 -2.47754792078 -3.94303981813 -26.3822567589 -2.47754792078 -3.94403981813 -26.3822567589 -2.47754792078 -3.94503981813 -26.3822567589 -2.47754792078 -3.94603981813 -26.3822567589 -2.47754792078 -3.94703981813 -26.3822567589 -2.47754792078 -3.94803981813 -26.3822567589 -2.47754792078 -3.94903981813 -26.3822567589 -2.47754792078 -3.95003981813 -26.3822567589 -2.47754792078 -3.95103981813 -26.3822567589 -2.47754792078 -3.95203981813 -26.3822567589 -2.47754792078 -3.95303981813 -26.3822567589 -2.47754792078 -3.95403981813 -26.3822567589 -2.47754792078 -3.95503981813 -26.3822567589 -2.47754792078 -3.95603981813 -26.3822567589 -2.47754792078 -3.95703981813 -26.3822567589 -2.47754792078 -3.95803981813 -26.3822567589 -2.47754792078 -3.95903981813 -26.3822567589 -2.47754792078 -3.96003981813 -26.3822567589 -2.47754792078 -3.96103981813 -26.3822567589 -2.47754792078 -3.96203981813 -26.3822567589 -2.47754792078 -3.96303981813 -26.3822567589 -2.47754792078 -3.96403981813 -26.3822567589 -2.47754792078 -3.96503981813 -26.3822567589 -2.47754792078 -3.96603981813 -26.3822567589 -2.47754792078 -3.96703981813 -26.3822567589 -2.47754792078 -3.96803981813 -26.3822567589 -2.47754792078 -3.96903981813 -26.3822567589 -2.47754792078 -3.97003981813 -26.3822567589 -2.47754792078 -3.97103981813 -26.3822567589 -2.47754792078 -3.97203981813 -26.3822567589 -2.47754792078 -3.97303981813 -26.3822567589 -2.47754792078 -3.97403981813 -26.3822567589 -2.47754792078 -3.97503981813 -26.3822567589 -2.47754792078 -3.97603981813 -26.3822567589 -2.47754792078 -3.97703981813 -26.3822567589 -2.47754792078 -3.97803981813 -26.3822567589 -2.47754792078 -3.97903981813 -26.3822567589 -2.47754792078 -3.98003981813 -26.3822567589 -2.47754792078 -3.98103981813 -26.3822567589 -2.47754792078 -3.98203981813 -26.3822567589 -2.47754792078 -3.98303981813 -26.3822567589 -2.47754792078 -3.98403981813 -26.3822567589 -2.47754792078 -3.98503981813 -26.3822567589 -2.47754792078 -3.98603981813 -26.3822567589 -2.47754792078 -3.98703981813 -26.3822567589 -2.47754792078 -3.98803981813 -26.3822567589 -2.47754792078 -3.98903981813 -26.3822567589 -2.47754792078 -3.99003981813 -26.3822567589 -2.47754792078 -3.99103981813 -26.3822567589 -2.47754792078 -3.99203981813 -26.3822567589 -2.47754792078 -3.99303981813 -26.3822567589 -2.47754792078 -3.99403981813 -26.3822567589 -2.47754792078 -3.99503981813 -26.3822567589 -2.47754792078 -3.99603981813 -26.3822567589 -2.47754792078 -3.99703981813 -26.3822567589 -2.47754792078 -3.99803981813 -26.3822567589 -2.47754792078 -3.99903981813 -26.3822567589 -2.47754792078 -4.00003981813 -26.3822567589 -2.47754792078 -4.00103981813 -26.3822567589 -2.47754792078 -4.00203981813 -26.3822567589 -2.47754792078 -4.00303981813 -26.3822567589 -2.47754792078 -4.00403981813 -26.3822567589 -2.47754792078 -4.00503981813 -26.3822567589 -2.47754792078 -4.00603981813 -26.3822567589 -2.47754792078 -4.00703981813 -26.3822567589 -2.47754792078 -4.00803981813 -26.3822567589 -2.47754792078 -4.00903981813 -26.3822567589 -2.47754792078 -4.01003981813 -26.3822567589 -2.47754792078 -4.01103981813 -26.3822567589 -2.47754792078 -4.01203981813 -26.3822567589 -2.47754792078 -4.01303981813 -26.3822567589 -2.47754792078 -4.01403981813 -26.3822567589 -2.47754792078 -4.01503981813 -26.3822567589 -2.47754792078 -4.01603981813 -26.3822567589 -2.47754792078 -4.01703981813 -26.3822567589 -2.47754792078 -4.01803981813 -26.3822567589 -2.47754792078 -4.01903981813 -26.3822567589 -2.47754792078 -4.02003981813 -26.3822567589 -2.47754792078 -4.02103981813 -26.3822567589 -2.47754792078 -4.02203981813 -26.3822567589 -2.47754792078 -4.02303981813 -26.3822567589 -2.47754792078 -4.02403981813 -26.3822567589 -2.47754792078 -4.02503981813 -26.3822567589 -2.47754792078 -4.02603981813 -26.3822567589 -2.47754792078 -4.02703981813 -26.3822567589 -2.47754792078 -4.02803981813 -26.3822567589 -2.47754792078 -4.02903981813 -26.3822567589 -2.47754792078 -4.03003981813 -26.3822567589 -2.47754792078 -4.03103981813 -26.3822567589 -2.47754792078 -4.03203981813 -26.3822567589 -2.47754792078 -4.03303981813 -26.3822567589 -2.47754792078 -4.03403981813 -26.3822567589 -2.47754792078 -4.03503981813 -26.3822567589 -2.47754792078 -4.03603981813 -26.3822567589 -2.47754792078 -4.03703981813 -26.3822567589 -2.47754792078 -4.03803981813 -26.3822567589 -2.47754792078 -4.03903981813 -26.3822567589 -2.47754792078 -4.04003981813 -26.3822567589 -2.47754792078 -4.04103981813 -26.3822567589 -2.47754792078 -4.04203981813 -26.3822567589 -2.47754792078 -4.04303981813 -26.3822567589 -2.47754792078 -4.04403981813 -26.3822567589 -2.47754792078 -4.04503981813 -26.3822567589 -2.47754792078 -4.04603981813 -26.3822567589 -2.47754792078 -4.04703981813 -26.3822567589 -2.47754792078 -4.04803981813 -26.3822567589 -2.47754792078 -4.04903981813 -26.3822567589 -2.47754792078 -4.05003981813 -26.3822567589 -2.47754792078 -4.05103981813 -26.3822567589 -2.47754792078 -4.05203981813 -26.3822567589 -2.47754792078 -4.05303981813 -26.3822567589 -2.47754792078 -4.05403981813 -26.3822567589 -2.47754792078 -4.05503981813 -26.3822567589 -2.47754792078 -4.05603981813 -26.3822567589 -2.47754792078 -4.05703981813 -26.3822567589 -2.47754792078 -4.05803981813 -26.3822567589 -2.47754792078 -4.05903981813 -26.3822567589 -2.47754792078 -4.06003981813 -26.3822567589 -2.47754792078 -4.06103981813 -26.3822567589 -2.47754792078 -4.06203981813 -26.3822567589 -2.47754792078 -4.06303981813 -26.3822567589 -2.47754792078 -4.06403981813 -26.3822567589 -2.47754792078 -4.06503981813 -26.3822567589 -2.47754792078 -4.06603981813 -26.3822567589 -2.47754792078 -4.06703981813 -26.3822567589 -2.47754792078 -4.06803981813 -26.3822567589 -2.47754792078 -4.06903981813 -26.3822567589 -2.47754792078 -4.07003981813 -26.3822567589 -2.47754792078 -4.07103981813 -26.3822567589 -2.47754792078 -4.07203981813 -26.3822567589 -2.47754792078 -4.07303981813 -26.3822567589 -2.47754792078 -4.07403981813 -26.3822567589 -2.47754792078 -4.07503981813 -26.3822567589 -2.47754792078 -4.07603981813 -26.3822567589 -2.47754792078 -4.07703981813 -26.3822567589 -2.47754792078 -4.07803981813 -26.3822567589 -2.47754792078 -4.07903981813 -26.3822567589 -2.47754792078 -4.08003981813 -26.3822567589 -2.47754792078 -4.08103981813 -26.3822567589 -2.47754792078 -4.08203981813 -26.3822567589 -2.47754792078 -4.08303981813 -26.3822567589 -2.47754792078 -4.08403981813 -26.3822567589 -2.47754792078 -4.08503981813 -26.3822567589 -2.47754792078 -4.08603981813 -26.3822567589 -2.47754792078 -4.08703981813 -26.3822567589 -2.47754792078 -4.08803981813 -26.3822567589 -2.47754792078 -4.08903981813 -26.3822567589 -2.47754792078 -4.09003981813 -26.3822567589 -2.47754792078 -4.09103981813 -26.3822567589 -2.47754792078 -4.09203981813 -26.3822567589 -2.47754792078 -4.09303981813 -26.3822567589 -2.47754792078 -4.09403981813 -26.3822567589 -2.47754792078 -4.09503981813 -26.3822567589 -2.47754792078 -4.09603981813 -26.3822567589 -2.47754792078 -4.09703981813 -26.3822567589 -2.47754792078 -4.09803981813 -26.3822567589 -2.47754792078 -4.09903981813 -26.3822567589 -2.47754792078 -4.10003981813 -26.3822567589 -2.47754792078 -4.10103981813 -26.3822567589 -2.47754792078 -4.10203981813 -26.3822567589 -2.47754792078 -4.10303981813 -26.3822567589 -2.47754792078 -4.10403981813 -26.3822567589 -2.47754792078 -4.10503981813 -26.3822567589 -2.47754792078 -4.10603981813 -26.3822567589 -2.47754792078 -4.10703981813 -26.3822567589 -2.47754792078 -4.10803981813 -26.3822567589 -2.47754792078 -4.10903981813 -26.3822567589 -2.47754792078 -4.11003981813 -26.3822567589 -2.47754792078 -4.11103981813 -26.3822567589 -2.47754792078 -4.11203981813 -26.3822567589 -2.47754792078 -4.11303981813 -26.3822567589 -2.47754792078 -4.11403981813 -26.3822567589 -2.47754792078 -4.11503981813 -26.3822567589 -2.47754792078 -4.11603981813 -26.3822567589 -2.47754792078 -4.11703981813 -26.3822567589 -2.47754792078 -4.11803981813 -26.3822567589 -2.47754792078 -4.11903981813 -26.3822567589 -2.47754792078 -4.12003981813 -26.3822567589 -2.47754792078 -4.12103981813 -26.3822567589 -2.47754792078 -4.12203981813 -26.3822567589 -2.47754792078 -4.12303981813 -26.3822567589 -2.47754792078 -4.12403981813 -26.3822567589 -2.47754792078 -4.12503981813 -26.3822567589 -2.47754792078 -4.12603981813 -26.3822567589 -2.47754792078 -4.12703981813 -26.3822567589 -2.47754792078 -4.12803981813 -26.3822567589 -2.47754792078 -4.12903981813 -26.3822567589 -2.47754792078 -4.13003981813 -26.3822567589 -2.47754792078 -4.13103981813 -26.3822567589 -2.47754792078 -4.13203981813 -26.3822567589 -2.47754792078 -4.13303981813 -26.3822567589 -2.47754792078 -4.13403981813 -26.3822567589 -2.47754792078 -4.13503981813 -26.3822567589 -2.47754792078 -4.13603981813 -26.3822567589 -2.47754792078 -4.13703981813 -26.3822567589 -2.47754792078 -4.13803981813 -26.3822567589 -2.47754792078 -4.13903981813 -26.3822567589 -2.47754792078 -4.14003981813 -26.3822567589 -2.47754792078 -4.14103981813 -26.3822567589 -2.47754792078 -4.14203981813 -26.3822567589 -2.47754792078 -4.14303981813 -26.3822567589 -2.47754792078 -4.14403981813 -26.3822567589 -2.47754792078 -4.14503981813 -26.3822567589 -2.47754792078 -4.14603981813 -26.3822567589 -2.47754792078 -4.14703981813 -26.3822567589 -2.47754792078 -4.14803981813 -26.3822567589 -2.47754792078 -4.14903981813 -26.3822567589 -2.47754792078 -4.15003981813 -26.3822567589 -2.47754792078 -4.15103981813 -26.3822567589 -2.47754792078 -4.15203981813 -26.3822567589 -2.47754792078 -4.15303981813 -26.3822567589 -2.47754792078 -4.15403981813 -26.3822567589 -2.47754792078 -4.15503981813 -26.3822567589 -2.47754792078 -4.15603981813 -26.3822567589 -2.47754792078 -4.15703981813 -26.3822567589 -2.47754792078 -4.15803981813 -26.3822567589 -2.47754792078 -4.15903981813 -26.3822567589 -2.47754792078 -4.16003981813 -26.3822567589 -2.47754792078 -4.16103981813 -26.3822567589 -2.47754792078 -4.16203981813 -26.3822567589 -2.47754792078 -4.16303981813 -26.3822567589 -2.47754792078 -4.16403981813 -26.3822567589 -2.47754792078 -4.16503981813 -26.3822567589 -2.47754792078 -4.16603981813 -26.3822567589 -2.47754792078 -4.16703981813 -26.3822567589 -2.47754792078 -4.16803981813 -26.3822567589 -2.47754792078 -4.16903981813 -26.3822567589 -2.47754792078 -4.17003981813 -26.3822567589 -2.47754792078 -4.17103981813 -26.3822567589 -2.47754792078 -4.17203981813 -26.3822567589 -2.47754792078 -4.17303981813 -26.3822567589 -2.47754792078 -4.17403981813 -26.3822567589 -2.47754792078 -4.17503981813 -26.3822567589 -2.47754792078 -4.17603981813 -26.3822567589 -2.47754792078 -4.17703981813 -26.3822567589 -2.47754792078 -4.17803981813 -26.3822567589 -2.47754792078 -4.17903981813 -26.3822567589 -2.47754792078 -4.18003981813 -26.3822567589 -2.47754792078 -4.18103981813 -26.3822567589 -2.47754792078 -4.18203981813 -26.3822567589 -2.47754792078 -4.18303981813 -26.3822567589 -2.47754792078 -4.18403981813 -26.3822567589 -2.47754792078 -4.18503981813 -26.3822567589 -2.47754792078 -4.18603981813 -26.3822567589 -2.47754792078 -4.18703981813 -26.3822567589 -2.47754792078 -4.18803981813 -26.3822567589 -2.47754792078 -4.18903981813 -26.3822567589 -2.47754792078 -4.19003981813 -26.3822567589 -2.47754792078 -4.19103981813 -26.3822567589 -2.47754792078 -4.19203981813 -26.3822567589 -2.47754792078 -4.19303981813 -26.3822567589 -2.47754792078 -4.19403981813 -26.3822567589 -2.47754792078 -4.19503981813 -26.3822567589 -2.47754792078 -4.19603981813 -26.3822567589 -2.47754792078 -4.19703981813 -26.3822567589 -2.47754792078 -4.19803981813 -26.3822567589 -2.47754792078 -4.19903981813 -26.3822567589 -2.47754792078 -4.20003981813 -26.3822567589 -2.47754792078 -4.20103981813 -26.3822567589 -2.47754792078 -4.20203981813 -26.3822567589 -2.47754792078 -4.20303981813 -26.3822567589 -2.47754792078 -4.20403981813 -26.3822567589 -2.47754792078 -4.20503981813 -26.3822567589 -2.47754792078 -4.20603981813 -26.3822567589 -2.47754792078 -4.20703981813 -26.3822567589 -2.47754792078 -4.20803981813 -26.3822567589 -2.47754792078 -4.20903981813 -26.3822567589 -2.47754792078 -4.21003981813 -26.3822567589 -2.47754792078 -4.21103981813 -26.3822567589 -2.47754792078 -4.21203981813 -26.3822567589 -2.47754792078 -4.21303981813 -26.3822567589 -2.47754792078 -4.21403981813 -26.3822567589 -2.47754792078 -4.21503981813 -26.3822567589 -2.47754792078 -4.21603981813 -26.3822567589 -2.47754792078 -4.21703981813 -26.3822567589 -2.47754792078 -4.21803981813 -26.3822567589 -2.47754792078 -4.21903981813 -26.3822567589 -2.47754792078 -4.22003981813 -26.3822567589 -2.47754792078 -4.22103981813 -26.3822567589 -2.47754792078 -4.22203981813 -26.3822567589 -2.47754792078 -4.22303981813 -26.3822567589 -2.47754792078 -4.22403981813 -26.3822567589 -2.47754792078 -4.22503981813 -26.3822567589 -2.47754792078 -4.22603981813 -26.3822567589 -2.47754792078 -4.22703981813 -26.3822567589 -2.47754792078 -4.22803981813 -26.3822567589 -2.47754792078 -4.22903981813 -26.3822567589 -2.47754792078 -4.23003981813 -26.3822567589 -2.47754792078 -4.23103981813 -26.3822567589 -2.47754792078 -4.23203981813 -26.3822567589 -2.47754792078 -4.23303981813 -26.3822567589 -2.47754792078 -4.23403981813 -26.3822567589 -2.47754792078 -4.23503981813 -26.3822567589 -2.47754792078 -4.23603981813 -26.3822567589 -2.47754792078 -4.23703981813 -26.3822567589 -2.47754792078 -4.23803981813 -26.3822567589 -2.47754792078 -4.23903981813 -26.3822567589 -2.47754792078 -4.24003981813 -26.3822567589 -2.47754792078 -4.24103981813 -26.3822567589 -2.47754792078 -4.24203981813 -26.3822567589 -2.47754792078 -4.24303981813 -26.3822567589 -2.47754792078 -4.24403981813 -26.3822567589 -2.47754792078 -4.24503981813 -26.3822567589 -2.47754792078 -4.24603981813 -26.3822567589 -2.47754792078 -4.24703981813 -26.3822567589 -2.47754792078 -4.24803981813 -26.3822567589 -2.47754792078 -4.24903981813 -26.3822567589 -2.47754792078 -4.25003981813 -26.3822567589 -2.47754792078 -4.25103981813 -26.3822567589 -2.47754792078 -4.25203981813 -26.3822567589 -2.47754792078 -4.25303981813 -26.3822567589 -2.47754792078 -4.25403981813 2061.27074064 -2.47754792078 -4.25503981813 3640.03763599 -2.47754792078 -4.25603981813 4709.11696555 -2.47754792078 -4.25703981813 5652.32656196 -2.47754792078 -4.25803981813 5275.42560871 -2.47754792078 -4.25903981813 4266.21151341 -2.47754792078 -4.26003981813 3405.58385181 -2.47754792078 -4.26103981813 2674.94393851 -2.47754792078 -4.26203981813 1451.95533808 -2.47754792078 -4.26303981813 674.61135151 -2.47754792078 -4.26403981813 20.2712793138 -2.47754792078 -4.26503981813 -350.393365893 -2.47754792078 -4.26603981813 -511.749124818 -2.47754792078 -4.26703981813 -209.062217568 -2.47754792078 -4.26803981813 -36.7571139429 -2.47754792078 -4.26903981813 393.609396017 -2.47754792078 -4.27003981813 600.911954369 -2.47754792078 -4.27103981813 1007.56416724 -2.47754792078 -4.27203981813 1235.54518093 -2.47754792078 -4.27303981813 1420.09996557 -2.47754792078 -4.27403981813 1789.74505089 -2.47754792078 -4.27503981813 1871.57463731 -2.47754792078 -4.27603981813 1892.23799246 -2.47754792078 -4.27703981813 1803.86258266 -2.47754792078 -4.27803981813 1717.14001046 -2.47754792078 -4.27903981813 1720.24766985 -2.47754792078 -4.28003981813 1621.90524951 -2.47754792078 -4.28103981813 1536.42596549 -2.47754792078 -4.28203981813 1501.47977531 -2.47754792078 -4.28303981813 1389.34706131 -2.47754792078 -4.28403981813 1311.05992229 -2.47754792078 -4.28503981813 1252.51118314 -2.47754792078 -4.28603981813 1166.92966226 -2.47754792078 -4.28703981813 1142.38392218 -2.47754792078 -4.28803981813 1152.47194433 -2.47754792078 -4.28903981813 1149.70728656 -2.47754792078 -4.29003981813 1143.32869199 -2.47754792078 -4.29103981813 1137.19155244 -2.47754792078 -4.29203981813 1136.68972104 -2.47754792078 -4.29303981813 1129.04037403 -2.47754792078 -4.29403981813 1124.27355503 -2.47754792078 -4.29503981813 1117.88876539 -2.47754792078 -4.29603981813 1134.22205243 -2.47754792078 -4.29703981813 1161.34987104 -2.47754792078 -4.29803981813 1176.02764992 -2.47754792078 -4.29903981813 1242.73885454 -2.47754792078 -4.30003981813 1253.18397449 -2.47754792078 -4.30103981813 1286.55019225 -2.47754792078 -4.30203981813 1309.49426381 -2.47754792078 -4.30303981813 1338.1405214 -2.47754792078 -4.30403981813 1364.14422963 -2.47754792078 -4.30503981813 1376.36160325 -2.47754792078 -4.30603981813 1362.60334577 -2.47754792078 -4.30703981813 1366.05977905 -2.47754792078 -4.30803981813 1389.67070098 -2.47754792078 -4.30903981813 1402.54386821 -2.47754792078 -4.31003981813 1384.37112917 -2.47754792078 -4.31103981813 1372.33394608 -2.47754792078 -4.31203981813 1363.92132326 -2.47754792078 -4.31303981813 1335.99551495 -2.47754792078 -4.31403981813 1318.5210518 -2.47754792078 -4.31503981813 1286.50034431 -2.47754792078 -4.31603981813 1300.84481523 -2.47754792078 -4.31703981813 1313.61258979 -2.47754792078 -4.31803981813 1301.60462326 -2.47754792078 -4.31903981813 1279.71774306 -2.47754792078 -4.32003981813 1249.425663 -2.47754792078 -4.32103981813 1222.37721985 -2.47754792078 -4.32203981813 1176.52662325 -2.47754792078 -4.32303981813 1140.55610402 -2.47754792078 -4.32403981813 1115.68550792 -2.47754792078 -4.32503981813 1108.92735663 -2.47754792078 -4.32603981813 1109.41168804 -2.47754792078 -4.32703981813 1090.72939482 -2.47754792078 -4.32803981813 1073.22368386 -2.47754792078 -4.32903981813 1049.57592104 -2.47754792078 -4.33003981813 1026.37489172 -2.47754792078 -4.33103981813 1007.01990017 -2.47754792078 -4.33203981813 978.955499174 -2.47754792078 -4.33303981813 955.316825969 -2.47754792078 -4.33403981813 927.462150774 -2.47754792078 -4.33503981813 895.629138997 -2.47754792078 -4.33603981813 871.519740594 -2.47754792078 -4.33703981813 848.518592744 -2.47754792078 -4.33803981813 818.565725206 -2.47754792078 -4.33903981813 780.961658932 -2.47754792078 -4.34003981813 759.628690822 -2.47754792078 -4.34103981813 729.003880634 -2.47754792078 -4.34203981813 711.681971234 -2.47754792078 -4.34303981813 694.243202164 -2.47754792078 -4.34403981813 665.741442521 -2.47754792078 -4.34503981813 649.31012864 -2.47754792078 -4.34603981813 630.859598505 -2.47754792078 -4.34703981813 617.492790336 -2.47754792078 -4.34803981813 603.873488705 -2.47754792078 -4.34903981813 584.107128404 -2.47754792078 -4.35003981813 569.368796782 -2.47754792078 -4.35103981813 556.921492188 -2.47754792078 -4.35203981813 542.55492938 -2.47754792078 -4.35303981813 532.105625931 -2.47754792078 -4.35403981813 530.008393073 -2.47754792078 -4.35503981813 527.403921399 -2.47754792078 -4.35603981813 515.43361898 -2.47754792078 -4.35703981813 501.757453393 -2.47754792078 -4.35803981813 473.07584193 -2.47754792078 -4.35903981813 457.219136862 -2.47754792078 -4.36003981813 438.901088143 -2.47754792078 -4.36103981813 427.677273111 -2.47754792078 -4.36203981813 416.109763723 -2.47754792078 -4.36303981813 399.693367323 -2.47754792078 -4.36403981813 389.15775338 -2.47754792078 -4.36503981813 385.777009636 -2.47754792078 -4.36603981813 383.556345411 -2.47754792078 -4.36703981813 380.666814673 -2.47754792078 -4.36803981813 379.635357693 -2.47754792078 -4.36903981813 383.914033759 -2.47754792078 -4.37003981813 392.013051825 -2.47754792078 -4.37103981813 401.864487625 -2.47754792078 -4.37203981813 401.635754706 -2.47754792078 -4.37303981813 404.027498313 -2.47754792078 -4.37403981813 411.21894866 -2.47754792078 -4.37503981813 413.735080163 -2.47754792078 -4.37603981813 408.276764496 -2.47754792078 -4.37703981813 410.000018093 -2.47754792078 -4.37803981813 415.756323443 -2.47754792078 -4.37903981813 416.670367122 -2.47754792078 -4.38003981813 416.07626995 -2.47754792078 -4.38103981813 409.549305857 -2.47754792078 -4.38203981813 402.25965543 -2.47754792078 -4.38303981813 392.015732079 -2.47754792078 -4.38403981813 386.977561363 -2.47754792078 -4.38503981813 385.056678662 -2.47754792078 -4.38603981813 378.092366252 -2.47754792078 -4.38703981813 375.914424369 -2.47754792078 -4.38803981813 371.330660073 -2.47754792078 -4.38903981813 366.48222835 -2.47754792078 -4.39003981813 363.541269196 -2.47754792078 -4.39103981813 367.318327355 -2.47754792078 -4.39203981813 372.714122178 -2.47754792078 -4.39303981813 377.561229094 -2.47754792078 -4.39403981813 379.258687857 -2.47754792078 -4.39503981813 380.879976875 -2.47754792078 -4.39603981813 381.476635855 -2.47754792078 -4.39703981813 382.510732786 -2.47754792078 -4.39803981813 382.789643683 -2.47754792078 -4.39903981813 385.550879347 -2.47754792078 -4.40003981813 386.889519938 -2.47754792078 -4.40103981813 388.194687641 -2.47754792078 -4.40203981813 387.15553417 -2.47754792078 -4.40303981813 386.899951889 -2.47754792078 -4.40403981813 388.113368204 -2.47754792078 -4.40503981813 386.877710735 -2.47754792078 -4.40603981813 390.979380152 -2.47754792078 -4.40703981813 394.376180113 -2.47754792078 -4.40803981813 396.321394762 -2.47754792078 -4.40903981813 398.073319006 -2.47754792078 -4.41003981813 403.463949669 -2.47754792078 -4.41103981813 410.479398445 -2.47754792078 -4.41203981813 417.009895314 -2.47754792078 -4.41303981813 425.780290616 -2.47754792078 -4.41403981813 429.451509864 -2.47754792078 -4.41503981813 431.496824515 -2.47754792078 -4.41603981813 434.083341433 -2.47754792078 -4.41703981813 433.705970895 -2.47754792078 -4.41803981813 430.33558662 -2.47754792078 -4.41903981813 428.063286373 -2.47754792078 -4.42003981813 429.713137245 -2.47754792078 -4.42103981813 425.511116115 -2.47754792078 -4.42203981813 421.299538028 -2.47754792078 -4.42303981813 422.955599152 -2.47754792078 -4.42403981813 422.67282969 -2.47754792078 -4.42503981813 424.275411784 -2.47754792078 -4.42603981813 430.278651792 -2.47754792078 -4.42703981813 437.984686707 -2.47754792078 -4.42803981813 445.49451047 -2.47754792078 -4.42903981813 450.545117239 -2.47754792078 -4.43003981813 457.273972463 -2.47754792078 -4.43103981813 459.600382333 -2.47754792078 -4.43203981813 460.298210279 -2.47754792078 -4.43303981813 462.428629241 -2.47754792078 -4.43403981813 464.848040404 -2.47754792078 -4.43503981813 466.146963318 -2.47754792078 -4.43603981813 464.893129172 -2.47754792078 -4.43703981813 453.027861857 -2.47754792078 -4.43803981813 448.935441535 -2.47754792078 -4.43903981813 448.539425307 -2.47754792078 -4.44003981813 446.653020504 -2.47754792078 -4.44103981813 442.354618517 -2.47754792078 -4.44203981813 439.106546938 -2.47754792078 -4.44303981813 438.806783256 -2.47754792078 -4.44403981813 439.623257391 -2.47754792078 -4.44503981813 441.817145018 -2.47754792078 -4.44603981813 454.754823729 -2.47754792078 -4.44703981813 466.178525347 -2.47754792078 -4.44803981813 471.50387405 -2.47754792078 -4.44903981813 483.290328952 -2.47754792078 -4.45003981813 485.8850541 -2.47754792078 -4.45103981813 489.106314936 -2.47754792078 -4.45203981813 489.431984823 -2.47754792078 -4.45303981813 499.585631729 -2.47754792078 -4.45403981813 495.82654897 -2.47754792078 -4.45503981813 493.395897736 -2.47754792078 -4.45603981813 493.41952594 -2.47754792078 -4.45703981813 492.181260957 -2.47754792078 -4.45803981813 493.016566315 -2.47754792078 -4.45903981813 493.493380168 -2.47754792078 -4.46003981813 495.085705828 -2.47754792078 -4.46103981813 496.978911774 -2.47754792078 -4.46203981813 493.054587866 -2.47754792078 -4.46303981813 501.951958236 -2.47754792078 -4.46403981813 501.981807966 -2.47754792078 -4.46503981813 504.273185726 -2.47754792078 -4.46603981813 509.7570169 -2.47754792078 -4.46703981813 520.138924505 -2.47754792078 -4.46803981813 528.364535249 -2.47754792078 -4.46903981813 542.848791603 -2.47754792078 -4.47003981813 537.394026169 -2.47754792078 -4.47103981813 535.050539781 -2.47754792078 -4.47203981813 534.352730265 -2.47754792078 -4.47303981813 524.804869993 -2.47754792078 -4.47403981813 537.440225089 -2.47754792078 -4.47503981813 535.409299163 -2.47754792078 -4.47603981813 531.986732391 -2.47754792078 -4.47703981813 528.980399646 -2.47754792078 -4.47803981813 516.804152843 -2.47754792078 -4.47903981813 528.029660587 -2.47754792078 -4.48003981813 526.830398842 -2.47754792078 -4.48103981813 526.801662038 -2.47754792078 -4.48203981813 525.327028738 -2.47754792078 -4.48303981813 515.15605334 -2.47754792078 -4.48403981813 530.893061677 -2.47754792078 -4.48503981813 528.131135251 -2.47754792078 -4.48603981813 527.053094406 -2.47754792078 -4.48703981813 527.296334204 -2.47754792078 -4.48803981813 517.796475219 -2.47754792078 -4.48903981813 535.065522118 -2.47754792078 -4.49003981813 534.689205995 -2.47754792078 -4.49103981813 533.444461677 -2.47754792078 -4.49203981813 519.044887879 -2.47754792078 -4.49303981813 533.777689303 -2.47754792078 -4.49403981813 531.02290263 -2.47754792078 -4.49503981813 529.932626265 -2.47754792078 -4.49603981813 529.390600999 -2.47754792078 -4.49703981813 530.191476798 -2.47754792078 -4.49803981813 533.940761525 -2.47754792078 -4.49903981813 536.142009817 -2.47754792078 -4.50003981813 538.783312253 -2.47754792078 -4.50103981813 539.146961243 1.06316352332 -4.50203981813 540.737209193 11.479911655 -4.50303981813 542.544335239 4.210417713 -4.50403981813 544.250886678 -0.87140339958 -4.50503981813 545.368537643 0.841254336143 -4.50603981813 546.289747403 1.72857293905 -4.50703981813 547.713284785 1.53508469676 -4.50803981813 549.319404555 1.44048086225 -4.50903981813 551.096515934 1.41831542789 -4.51003981813 552.962479871 1.41831542789 -4.51103981813 554.133740305 1.41831542789 -4.51203981813 555.913627744 1.41831542789 -4.51303981813 557.825205722 1.41831542789 -4.51403981813 560.592701535 0.98369907675 -4.51503981813 559.742157915 5.44215097662 -4.51603981813 560.603164612 2.36691740591 -4.51703981813 560.266239002 0.845688050082 -4.51803981813 540.949349916 1.20058421585 -4.51903981813 554.898545704 1.28492929317 -4.52003981813 554.926415228 1.28492929317 -4.52103981813 554.461692762 1.28492929317 -4.52203981813 554.625693965 1.28492929317 -4.52303981813 555.195437601 1.28492929317 -4.52403981813 556.24645883 1.28492929317 -4.52503981813 557.041594177 1.28492929317 -4.52603981813 559.064647052 1.28492929317 -4.52703981813 563.716345441 1.28492929317 -4.52803981813 568.976725583 1.28492929317 -4.52903981813 539.523203242 1.28492929317 -4.53003981813 565.385422384 1.28492929317 -4.53103981813 562.188747028 1.28492929317 -4.53203981813 559.442058503 1.28492929317 -4.53303981813 556.105362942 1.28492929317 -4.53403981813 556.21402861 1.28492929317 -4.53503981813 563.33823812 1.28492929317 -4.53603981813 556.025603912 1.28492929317 -4.53703981813 556.878452905 1.28492929317 -4.53803981813 557.157674602 1.28492929317 -4.53903981813 566.018420577 1.28492929317 -4.54003981813 569.965554662 1.28492929317 -4.54103981813 535.242678408 1.28492929317 -4.54203981813 567.740143087 1.28492929317 -4.54303981813 564.685272946 1.28492929317 -4.54403981813 577.379393798 1.28492929317 -4.54503981813 580.14582897 1.28492929317 -4.54603981813 536.300331622 1.28492929317 -4.54703981813 571.87089222 1.28492929317 -4.54803981813 573.027161741 1.28492929317 -4.54903981813 573.094100348 1.28492929317 -4.55003981813 579.328439524 1.28492929317 -4.55103981813 586.105858968 1.28492929317 -4.55203981813 592.157998473 1.28492929317 -4.55303981813 597.710209963 1.28492929317 -4.55403981813 603.382599627 1.28492929317 -4.55503981813 542.792078152 1.28492929317 -4.55603981813 597.684332307 1.28492929317 -4.55703981813 600.376723625 1.28492929317 -4.55803981813 604.918479485 1.28492929317 -4.55903981813 614.050914423 1.28492929317 -4.56003981813 622.973099993 1.28492929317 -4.56103981813 630.298249022 1.28492929317 -4.56203981813 655.474293126 1.28492929317 -4.56303981813 645.342879834 1.28492929317 -4.56403981813 634.597863505 1.28492929317 -4.56503981813 638.812517679 1.28492929317 -4.56603981813 632.36671832 1.28492929317 -4.56703981813 648.91906922 1.28492929317 -4.56803981813 651.383113608 1.28492929317 -4.56903981813 663.023666371 1.28492929317 -4.57003981813 682.121724192 1.28492929317 -4.57103981813 683.541566201 1.28492929317 -4.57203981813 687.022507932 1.28492929317 -4.57303981813 691.247925524 1.28492929317 -4.57403981813 709.732618263 1.28492929317 -4.57503981813 688.86062483 1.28492929317 -4.57603981813 680.698008368 1.28492929317 -4.57703981813 673.661466387 1.28492929317 -4.57803981813 674.055126179 1.28492929317 -4.57903981813 673.739464068 1.28492929317 -4.58003981813 704.696688227 1.28492929317 -4.58103981813 690.68999947 1.28492929317 -4.58203981813 651.880015516 1.28492929317 -4.58303981813 666.456415478 1.28492929317 -4.58403981813 626.279194848 1.28492929317 -4.58503981813 664.152610745 1.28492929317 -4.58603981813 625.138602365 1.28492929317 -4.58703981813 630.428331034 1.28492929317 -4.58803981813 569.409127041 1.28492929317 -4.58903981813 626.430501793 1.28492929317 -4.59003981813 640.102465544 1.28492929317 -4.59103981813 687.745525762 1.28492929317 -4.59203981813 675.087166072 1.28492929317 -4.59303981813 697.361181893 1.28492929317 -4.59403981813 666.476998601 1.28492929317 -4.59503981813 679.568482555 1.28492929317 -4.59603981813 691.465884871 1.28492929317 -4.59703981813 672.418096277 1.28492929317 -4.59803981813 691.701028326 1.28492929317 -4.59903981813 743.587132105 1.28492929317 -4.60003981813 810.995575489 1.28492929317 -4.60103981813 779.787393902 1.28492929317 -4.60203981813 757.14884128 1.28492929317 -4.60303981813 782.540306741 1.28492929317 -4.60403981813 779.305089689 1.28492929317 -4.60503981813 804.803843099 1.28492929317 -4.60603981813 795.900300417 1.28492929317 -4.60703981813 815.837676717 1.28492929317 -4.60803981813 806.488368929 1.28492929317 -4.60903981813 833.577992532 1.28492929317 -4.61003981813 801.110724253 1.28492929317 -4.61103981813 784.384803152 1.28492929317 -4.61203981813 745.166883204 1.28492929317 -4.61303981813 714.691738013 1.28492929317 -4.61403981813 690.72255005 1.28492929317 -4.61503981813 665.454926022 1.28492929317 -4.61603981813 624.503383237 1.28492929317 -4.61703981813 597.288220558 1.28492929317 -4.61803981813 555.956510448 1.28492929317 -4.61903981813 548.719113637 1.28492929317 -4.62003981813 501.939781758 1.28492929317 -4.62103981813 474.292631412 1.28492929317 -4.62203981813 407.381090462 1.28492929317 -4.62303981813 438.249496342 1.28492929317 -4.62403981813 443.500346788 1.28492929317 -4.62503981813 474.777414519 1.28492929317 -4.62603981813 588.842564818 1.28492929317 -4.62703981813 624.524209647 1.28492929317 -4.62803981813 653.803439669 1.28492929317 -4.62903981813 808.873611654 1.28492929317 -4.63003981813 1019.32614043 1.28492929317 -4.63103981813 1064.60096231 1.28492929317 -4.63203981813 1075.49800624 1.28492929317 -4.63303981813 1122.47201497 1.28492929317 -4.63403981813 1128.35789235 1.28492929317 -4.63503981813 1168.84250329 1.28492929317 -4.63603981813 1176.88912641 1.28492929317 -4.63703981813 1193.69342739 1.28492929317 -4.63803981813 1208.04603951 1.28492929317 -4.63903981813 1178.76544302 1.28492929317 -4.64003981813 1187.8821354 1.28492929317 -4.64103981813 1198.51013695 1.28492929317 -4.64203981813 1079.94543782 1.28492929317 -4.64303981813 971.001305827 1.28492929317 -4.64403981813 921.918388701 1.28492929317 -4.64503981813 909.255506167 1.28492929317 -4.64603981813 847.070474255 1.28492929317 -4.64703981813 774.560469457 1.28492929317 -4.64803981813 714.332013176 1.28492929317 -4.64903981813 705.948051656 1.28492929317 -4.65003981813 649.146542452 1.28492929317 -4.65103981813 616.544523034 1.28492929317 -4.65203981813 605.854921673 1.28492929317 -4.65303981813 591.973098739 1.28492929317 -4.65403981813 618.749520712 1.28492929317 -4.65503981813 572.981546753 1.28492929317 -4.65603981813 589.20421019 1.28492929317 -4.65703981813 589.800253496 1.28492929317 -4.65803981813 548.294590999 1.28492929317 -4.65903981813 547.088626925 1.28492929317 -4.66003981813 585.983436049 1.28492929317 -4.66103981813 630.888664529 1.28492929317 -4.66203981813 651.856901149 1.28492929317 -4.66303981813 677.053188051 1.28492929317 -4.66403981813 690.599400393 1.28492929317 -4.66503981813 704.160679831 1.28492929317 -4.66603981813 718.789519227 1.28492929317 -4.66703981813 732.465610531 1.28492929317 -4.66803981813 750.166322986 1.28492929317 -4.66903981813 786.380569649 1.28492929317 -4.67003981813 837.744458322 1.28492929317 -4.67103981813 843.295219128 1.28492929317 -4.67203981813 801.726227946 1.28492929317 -4.67303981813 777.572522706 1.28492929317 -4.67403981813 761.021380969 1.28492929317 -4.67503981813 726.02965766 1.28492929317 -4.67603981813 713.328193007 1.28492929317 -4.67703981813 719.827066642 1.28492929317 -4.67803981813 731.147486283 1.28492929317 -4.67903981813 725.846330532 1.28492929317 -4.68003981813 707.739949548 1.28492929317 -4.68103981813 680.305563677 1.28492929317 -4.68203981813 684.407560455 1.28492929317 -4.68303981813 668.667672668 1.28492929317 -4.68403981813 653.538217242 1.28492929317 -4.68503981813 646.759031611 1.28492929317 -4.68603981813 631.511381983 1.28492929317 -4.68703981813 640.490688016 1.28492929317 -4.68803981813 604.330302264 1.28492929317 -4.68903981813 563.50583541 1.28492929317 -4.69003981813 604.98779887 1.28492929317 -4.69103981813 581.393461635 1.28492929317 -4.69203981813 561.81663107 1.28492929317 -4.69303981813 560.899992641 1.28492929317 -4.69403981813 555.938981678 1.28492929317 -4.69503981813 565.981055365 1.28492929317 -4.69603981813 557.40942203 1.28492929317 -4.69703981813 553.687309807 1.28492929317 -4.69803981813 540.195396042 1.28492929317 -4.69903981813 538.421351995 1.28492929317 -4.70003981813 540.88755349 1.28492929317 -4.70103981813 537.938272377 1.28492929317 -4.70203981813 536.152752302 1.28492929317 -4.70303981813 528.978037693 1.28492929317 -4.70403981813 525.291855817 1.28492929317 -4.70503981813 526.615337586 1.28492929317 -4.70603981813 527.878625522 1.28492929317 -4.70703981813 523.892661512 1.28492929317 -4.70803981813 518.630689842 1.28492929317 -4.70903981813 517.1545951 1.28492929317 -4.71003981813 518.615071757 1.28492929317 -4.71103981813 504.662830348 1.28492929317 -4.71203981813 499.06305718 1.28492929317 -4.71303981813 491.761304709 1.28492929317 -4.71403981813 487.231498108 1.28492929317 -4.71503981813 477.836857562 1.28492929317 -4.71603981813 486.600655907 1.28492929317 -4.71703981813 484.829757046 1.28492929317 -4.71803981813 482.363224578 1.28492929317 -4.71903981813 468.795540411 1.28492929317 -4.72003981813 460.623320473 1.28492929317 -4.72103981813 450.25759096 1.28492929317 -4.72203981813 469.398800518 1.28492929317 -4.72303981813 466.875479125 1.28492929317 -4.72403981813 473.407103345 1.28492929317 -4.72503981813 465.843732831 1.28492929317 -4.72603981813 475.266856586 1.28492929317 -4.72703981813 480.264645477 1.28492929317 -4.72803981813 479.54499402 1.28492929317 -4.72903981813 479.98971697 1.28492929317 -4.73003981813 478.419634885 1.28492929317 -4.73103981813 467.818490586 1.28492929317 -4.73203981813 465.971455103 1.28492929317 -4.73303981813 459.53782729 1.28492929317 -4.73403981813 456.047767964 1.28492929317 -4.73503981813 458.530132312 1.28492929317 -4.73603981813 450.280445304 1.28492929317 -4.73703981813 436.974944338 1.28492929317 -4.73803981813 431.951015623 1.28492929317 -4.73903981813 429.369207785 1.28492929317 -4.74003981813 435.636573264 1.28492929317 -4.74103981813 429.267558159 1.28492929317 -4.74203981813 429.692093918 1.28492929317 -4.74303981813 433.573379536 1.28492929317 -4.74403981813 446.898994853 1.28492929317 -4.74503981813 445.673309546 1.28492929317 -4.74603981813 441.474201626 1.28492929317 -4.74703981813 441.754011666 1.28492929317 -4.74803981813 469.790343809 1.28492929317 -4.74903981813 444.079772313 1.28492929317 -4.75003981813 437.559242568 1.28492929317 -4.75103981813 439.527614983 1.28492929317 -4.75203981813 418.183456011 1.28492929317 -4.75303981813 415.760678848 1.28492929317 -4.75403981813 389.55098053 1.28492929317 -4.75503981813 373.537455056 1.28492929317 -4.75603981813 385.104365833 1.28492929317 -4.75703981813 378.720297943 1.28492929317 -4.75803981813 373.767742495 1.28492929317 -4.75903981813 371.776034899 1.28492929317 -4.76003981813 383.242620197 1.28492929317 -4.76103981813 381.854121457 1.28492929317 -4.76203981813 381.829551955 1.28492929317 -4.76303981813 382.08764178 1.28492929317 -4.76403981813 378.420932033 1.28492929317 -4.76503981813 382.698699495 1.28492929317 -4.76603981813 385.048197897 1.28492929317 -4.76703981813 380.758187168 1.28492929317 -4.76803981813 384.211573663 1.28492929317 -4.76903981813 378.70726957 1.28492929317 -4.77003981813 374.983082764 1.28492929317 -4.77103981813 366.472412685 1.28492929317 -4.77203981813 374.92768578 1.28492929317 -4.77303981813 368.912769382 1.28492929317 -4.77403981813 365.813081485 1.28492929317 -4.77503981813 390.29440318 1.28492929317 -4.77603981813 386.689967887 1.28492929317 -4.77703981813 367.242151531 1.28492929317 -4.77803981813 359.250702858 1.28492929317 -4.77903981813 364.733876088 1.28492929317 -4.78003981813 349.560834091 1.28492929317 -4.78103981813 349.659594302 1.28492929317 -4.78203981813 339.880527916 1.28492929317 -4.78303981813 336.085012806 1.28492929317 -4.78403981813 335.132241874 1.28492929317 -4.78503981813 329.098323631 1.28492929317 -4.78603981813 330.801826207 1.28492929317 -4.78703981813 334.800065438 1.28492929317 -4.78803981813 333.363272345 1.28492929317 -4.78903981813 342.879318183 1.28492929317 -4.79003981813 338.912361948 1.28492929317 -4.79103981813 340.648005307 1.28492929317 -4.79203981813 344.244603834 1.28492929317 -4.79303981813 346.034352555 1.28492929317 -4.79403981813 347.787353433 1.28492929317 -4.79503981813 354.951510538 1.28492929317 -4.79603981813 345.136663281 1.28492929317 -4.79703981813 340.263440773 1.28492929317 -4.79803981813 340.447817937 1.28492929317 -4.79903981813 341.010811942 1.28492929317 -4.80003981813 340.564802912 1.28492929317 -4.80103981813 344.36918773 1.28492929317 -4.80203981813 346.041320231 1.28492929317 -4.80303981813 343.017246744 1.28492929317 -4.80403981813 342.408646256 1.28492929317 -4.80503981813 340.270286344 1.28492929317 -4.80603981813 335.183065057 1.28492929317 -4.80703981813 327.269650012 1.28492929317 -4.80803981813 323.176243315 1.28492929317 -4.80903981813 321.005345101 1.28492929317 -4.81003981813 321.508110622 1.28492929317 -4.81103981813 319.497620476 1.28492929317 -4.81203981813 313.996034266 1.28492929317 -4.81303981813 311.654489104 1.28492929317 -4.81403981813 309.828288683 1.28492929317 -4.81503981813 316.588821146 1.28492929317 -4.81603981813 308.260374251 1.28492929317 -4.81703981813 312.267634206 1.28492929317 -4.81803981813 312.42331934 1.28492929317 -4.81903981813 308.307815324 1.28492929317 -4.82003981813 306.05374902 1.28492929317 -4.82103981813 305.964928498 1.28492929317 -4.82203981813 303.908366992 1.28492929317 -4.82303981813 318.404071675 1.28492929317 -4.82403981813 315.498949403 1.28492929317 -4.82503981813 320.343452931 1.28492929317 -4.82603981813 316.999028815 1.28492929317 -4.82703981813 304.800602769 1.28492929317 -4.82803981813 290.395500847 1.28492929317 -4.82903981813 289.493219597 1.28492929317 -4.83003981813 286.504814155 1.28492929317 -4.83103981813 282.193674625 1.28492929317 -4.83203981813 274.868623024 1.28492929317 -4.83303981813 283.097295416 1.28492929317 -4.83403981813 279.214433856 1.28492929317 -4.83503981813 269.286515854 1.28492929317 -4.83603981813 264.203200317 1.28492929317 -4.83703981813 275.910483262 1.28492929317 -4.83803981813 278.76185976 1.28492929317 -4.83903981813 270.614537981 1.28492929317 -4.84003981813 252.048944727 1.28492929317 -4.84103981813 262.840448287 1.28492929317 -4.84203981813 258.328551376 1.28492929317 -4.84303981813 248.142518232 1.28492929317 -4.84403981813 225.534872794 1.28492929317 -4.84503981813 242.325366656 1.28492929317 -4.84603981813 222.15255125 1.28492929317 -4.84703981813 219.394278409 1.28492929317 -4.84803981813 219.120567806 1.28492929317 -4.84903981813 187.67685245 1.28492929317 -4.85003981813 200.547002446 1.28492929317 -4.85103981813 201.175750061 1.28492929317 -4.85203981813 196.719941466 1.28492929317 -4.85303981813 188.449891275 1.28492929317 -4.85403981813 195.887525731 1.28492929317 -4.85503981813 174.893045485 1.28492929317 -4.85603981813 150.817591265 1.28492929317 -4.85703981813 153.964863266 1.28492929317 -4.85803981813 152.342946328 1.28492929317 -4.85903981813 141.54994031 1.28492929317 -4.86003981813 139.384458832 1.28492929317 -4.86103981813 140.151708173 1.28492929317 -4.86203981813 139.421220805 1.28492929317 -4.86303981813 127.744705509 1.28492929317 -4.86403981813 135.565593148 1.28492929317 -4.86503981813 137.611036167 1.28492929317 -4.86603981813 155.649009674 1.28492929317 -4.86703981813 98.0175880678 1.28492929317 -4.86803981813 122.5302823 1.28492929317 -4.86903981813 102.562216595 1.28492929317 -4.87003981813 128.853130695 1.28492929317 -4.87103981813 133.105167032 1.28492929317 -4.87203981813 160.287330265 1.28492929317 -4.87303981813 149.099556634 1.28492929317 -4.87403981813 144.859321241 1.28492929317 -4.87503981813 136.87671698 1.28492929317 -4.87603981813 170.613813859 1.28492929317 -4.87703981813 166.939563918 1.28492929317 -4.87803981813 151.313067755 1.28492929317 -4.87903981813 127.583270595 1.28492929317 -4.88003981813 132.955369562 1.28492929317 -4.88103981813 130.858879061 1.28492929317 -4.88203981813 114.818828963 1.28492929317 -4.88303981813 91.0914391163 1.28492929317 -4.88403981813 101.440396501 1.28492929317 -4.88503981813 92.9430557214 1.28492929317 -4.88603981813 83.5412195074 1.28492929317 -4.88703981813 69.8340561271 1.28492929317 -4.88803981813 91.0132426863 1.28492929317 -4.88903981813 83.0288060727 1.28492929317 -4.89003981813 73.6754755975 1.28492929317 -4.89103981813 51.4394604933 1.28492929317 -4.89203981813 69.9779004838 1.28492929317 -4.89303981813 52.1979329601 1.28492929317 -4.89403981813 38.2438920144 1.28492929317 -4.89503981813 22.1215340771 1.28492929317 -4.89603981813 49.6287790473 1.28492929317 -4.89703981813 40.6287808226 1.28492929317 -4.89803981813 23.1996378599 1.28492929317 -4.89903981813 45.2990428193 1.28492929317 -4.90003981813 30.0369579282 1.28492929317 -4.90103981813 5.89924807763 1.28492929317 -4.90203981813 17.9305284116 1.28492929317 -4.90303981813 27.7850070396 1.28492929317 -4.90403981813 8.92580175981 1.28492929317 -4.90503981813 30.6468447865 1.28492929317 -4.90603981813 17.5045655104 1.28492929317 -4.90703981813 7.46394021341 1.28492929317 -4.90803981813 2.54600116971 1.28492929317 -4.90903981813 -4.6755526319 1.28492929317 -4.91003981813 3.93096786042 1.28492929317 -4.91103981813 -0.314036779387 1.28492929317 -4.91203981813 -8.0561770513 1.28492929317 -4.91303981813 -7.06201859641 1.28492929317 -4.91403981813 -2.77178066932 1.28492929317 -4.91503981813 -2.59729493241 1.28492929317 -4.91603981813 -1.45307505747 1.28492929317 -4.91703981813 1.40412032521 1.28492929317 -4.91803981813 -0.747043331619 1.28492929317 -4.91903981813 -0.974608802041 1.28492929317 -4.92003981813 -1.35226136182 1.28492929317 -4.92103981813 6.49681145729 1.28492929317 -4.92203981813 19.0181542195 1.28492929317 -4.92303981813 6.93131728385 1.28492929317 -4.92403981813 4.29890710813 1.28492929317 -4.92503981813 3.22142423948 1.28492929317 -4.92603981813 15.3206181157 1.28492929317 -4.92703981813 67.7686413374 1.28492929317 -4.92803981813 61.6332626117 1.28492929317 -4.92903981813 40.1194548039 1.28492929317 -4.93003981813 23.2581620907 1.28492929317 -4.93103981813 5.50757068146 1.28492929317 -4.93203981813 4.29776636547 1.28492929317 -4.93303981813 -3.49065647063 1.28492929317 -4.93403981813 -11.0626006419 1.28492929317 -4.93503981813 -15.9709108616 1.28492929317 -4.93603981813 -19.1273957012 1.28492929317 -4.93703981813 -22.4396345078 1.28492929317 -4.93803981813 -30.2214759299 1.28492929317 -4.93903981813 -34.6366108033 1.28492929317 -4.94003981813 -48.0390905222 1.28492929317 -4.94103981813 -44.8024807297 1.28492929317 -4.94203981813 -47.8402678582 1.28492929317 -4.94303981813 -56.5602547561 1.28492929317 -4.94403981813 -50.0334691198 1.28492929317 -4.94503981813 -52.8526342416 1.28492929317 -4.94603981813 -62.9156981502 1.28492929317 -4.94703981813 -50.2951402495 1.28492929317 -4.94803981813 -36.4252317803 1.28492929317 -4.94903981813 -48.5017805916 1.28492929317 -4.95003981813 -43.1542044796 1.28492929317 -4.95103981813 -55.8586723393 1.28492929317 -4.95203981813 -71.5644717146 1.28492929317 -4.95303981813 -60.2627248031 1.28492929317 -4.95403981813 -55.6876655957 1.28492929317 -4.95503981813 -69.7128644394 1.28492929317 -4.95603981813 -43.1380117163 1.28492929317 -4.95703981813 -48.5242428841 1.28492929317 -4.95803981813 -17.4685587123 1.28492929317 -4.95903981813 -15.9716107889 1.28492929317 -4.96003981813 -2.18385534383 1.28492929317 -4.96103981813 24.13308104 1.28492929317 -4.96203981813 35.4457155649 1.28492929317 -4.96303981813 14.6528734459 1.28492929317 -4.96403981813 53.8953226468 1.28492929317 -4.96503981813 43.6389853953 1.28492929317 -4.96603981813 34.0759569892 1.28492929317 -4.96703981813 57.923391686 1.28492929317 -4.96803981813 52.426777894 1.28492929317 -4.96903981813 59.9623895229 1.28492929317 -4.97003981813 57.3275884322 1.28492929317 -4.97103981813 57.3039697847 1.28492929317 -4.97203981813 73.4972646583 1.28492929317 -4.97303981813 80.0089360592 1.28492929317 -4.97403981813 127.302253114 1.28492929317 -4.97503981813 137.046415972 1.28492929317 -4.97603981813 106.393297743 1.28492929317 -4.97703981813 119.720453206 1.28492929317 -4.97803981813 93.8205956197 1.28492929317 -4.97903981813 79.4964991713 1.28492929317 -4.98003981813 74.4200349164 1.28492929317 -4.98103981813 71.5786146605 1.28492929317 -4.98203981813 98.9282886289 1.28492929317 -4.98303981813 77.8434155376 1.28492929317 -4.98403981813 71.6563489902 1.28492929317 -4.98503981813 99.4551043614 1.28492929317 -4.98603981813 68.4929340603 1.28492929317 -4.98703981813 57.7065723589 1.28492929317 -4.98803981813 74.8808557186 1.28492929317 -4.98903981813 72.7102716111 1.28492929317 -4.99003981813 99.5515647078 1.28492929317 -4.99103981813 128.733758856 1.28492929317 -4.99203981813 122.899063736 1.28492929317 -4.99303981813 92.7234187527 1.28492929317 -4.99403981813 83.8555053188 1.28492929317 -4.99503981813 95.8431799703 1.28492929317 -4.99603981813 109.036486167 1.28492929317 -4.99703981813 90.27487527 1.28492929317 -4.99803981813 92.3843485937 1.28492929317 -4.99903981813 103.796086945 1.28492929317 -5.00003981813 74.0655546883 1.28492929317 -5.00103981813 84.6302785807 1.28492929317 -5.00203981813 91.8210250343 1.28492929317 -5.00303981813 82.5664178956 1.28492929317 -5.00403981813 53.5226539543 1.28492929317 -5.00503981813 101.823906321 1.28492929317 -5.00603981813 83.2042221468 1.28492929317 -5.00703981813 54.2466740071 1.28492929317 -5.00803981813 89.8069901587 1.28492929317 -5.00903981813 78.3866848497 1.28492929317 -5.01003981813 46.7415963543 1.28492929317 -5.01103981813 98.440638793 1.28492929317 -5.01203981813 85.9744612036 1.28492929317 -5.01303981813 79.2370895169 1.28492929317 -5.01403981813 95.9096167392 1.28492929317 -5.01503981813 102.124785948 1.28492929317 -5.01603981813 99.014199621 1.28492929317 -5.01703981813 57.8537020903 1.28492929317 -5.01803981813 111.743191853 1.28492929317 -5.01903981813 102.281693112 1.28492929317 -5.02003981813 84.4662681924 1.28492929317 -5.02103981813 80.3368940509 1.28492929317 -5.02203981813 79.7150947898 1.28492929317 -5.02303981813 80.5081136784 1.28492929317 -5.02403981813 84.835895609 1.28492929317 -5.02503981813 81.2644722036 1.28492929317 -5.02603981813 82.008535825 1.28492929317 -5.02703981813 91.8038565682 1.28492929317 -5.02803981813 122.877381124 1.28492929317 -5.02903981813 84.0074830524 1.28492929317 -5.03003981813 60.3174834636 1.28492929317 -5.03103981813 84.0700497629 1.28492929317 -5.03203981813 56.4102405467 1.28492929317 -5.03303981813 78.1630820189 1.28492929317 -5.03403981813 45.3430535901 1.28492929317 -5.03503981813 81.9243326261 1.28492929317 -5.03603981813 78.2203722949 1.28492929317 -5.03703981813 66.9329876465 1.28492929317 -5.03803981813 64.2028742756 1.28492929317 -5.03903981813 92.9784338402 1.28492929317 -5.04003981813 70.7351023982 1.28492929317 -5.04103981813 67.5402265074 1.28492929317 -5.04203981813 98.9438778041 1.28492929317 -5.04303981813 54.8905924655 1.28492929317 -5.04403981813 93.2968367206 1.28492929317 -5.04503981813 87.6669698966 1.28492929317 -5.04603981813 76.7218622198 1.28492929317 -5.04703981813 77.4046991622 1.28492929317 -5.04803981813 101.567721908 1.28492929317 -5.04903981813 69.6091118347 1.28492929317 -5.05003981813 86.2215301505 1.28492929317 -5.05103981813 65.7430364655 1.28492929317 -5.05203981813 102.78600001 1.28492929317 -5.05303981813 101.566997343 1.28492929317 -5.05403981813 78.1041582869 1.28492929317 -5.05503981813 95.6532661069 1.28492929317 -5.05603981813 104.12665853 1.28492929317 -5.05703981813 77.4667915008 1.28492929317 -5.05803981813 98.6754148912 1.28492929317 -5.05903981813 107.386143995 1.28492929317 -5.06003981813 68.5054594754 1.28492929317 -5.06103981813 92.3311008167 1.28492929317 -5.06203981813 85.2621665918 1.28492929317 -5.06303981813 76.7383409928 1.28492929317 -5.06403981813 89.0070807246 1.28492929317 -5.06503981813 81.5198316568 1.28492929317 -5.06603981813 63.6773916419 1.28492929317 -5.06703981813 66.4529087677 1.28492929317 -5.06803981813 63.4974244058 1.28492929317 -5.06903981813 82.6967128374 1.28492929317 -5.07003981813 41.2308431595 1.28492929317 -5.07103981813 86.8062018346 1.28492929317 -5.07203981813 36.0354481184 1.28492929317 -5.07303981813 91.5536124271 1.28492929317 -5.07403981813 26.9922767129 1.28492929317 -5.07503981813 83.8173642735 1.28492929317 -5.07603981813 38.4838329666 1.28492929317 -5.07703981813 67.3069538591 1.28492929317 -5.07803981813 50.399484033 1.28492929317 -5.07903981813 44.2212492815 1.28492929317 -5.08003981813 56.083070679 1.28492929317 -5.08103981813 70.2195781258 1.28492929317 -5.08203981813 42.9507853134 1.28492929317 -5.08303981813 82.4738838404 1.28492929317 -5.08403981813 56.1260039586 1.28492929317 -5.08503981813 27.627879138 1.28492929317 -5.08603981813 56.9778857872 1.28492929317 -5.08703981813 66.1249561803 1.28492929317 -5.08803981813 16.5606162996 1.28492929317 -5.08903981813 64.5806277215 1.28492929317 -5.09003981813 46.5929434407 1.28492929317 -5.09103981813 44.3806237945 1.28492929317 -5.09203981813 58.000236516 1.28492929317 -5.09303981813 54.1266398548 1.28492929317 -5.09403981813 51.0333426335 1.28492929317 -5.09503981813 54.2994468789 1.28492929317 -5.09603981813 48.9808764672 1.28492929317 -5.09703981813 63.6463745362 1.28492929317 -5.09803981813 53.3411866019 1.28492929317 -5.09903981813 48.941656869 1.28492929317 -5.10003981813 61.2650451361 1.28492929317 -5.10103981813 71.8131503729 1.28492929317 -5.10203981813 62.0912363248 1.28492929317 -5.10303981813 19.2850008263 1.28492929317 -5.10403981813 59.6776700023 1.28492929317 -5.10503981813 76.7893318272 1.28492929317 -5.10603981813 47.4965158075 1.28492929317 -5.10703981813 67.2767839655 1.28492929317 -5.10803981813 38.9312530113 1.28492929317 -5.10903981813 59.4098352883 1.28492929317 -5.11003981813 33.9648549712 1.28492929317 -5.11103981813 52.9067396463 1.28492929317 -5.11203981813 30.0014310012 1.28492929317 -5.11303981813 46.2172374036 1.28492929317 -5.11403981813 30.5564747916 1.28492929317 -5.11503981813 42.7534319001 1.28492929317 -5.11603981813 46.3064431755 1.28492929317 -5.11703981813 33.5368082061 1.28492929317 -5.11803981813 28.3167669237 1.28492929317 -5.11903981813 14.405774304 1.28492929317 -5.12003981813 26.2629462878 1.28492929317 -5.12103981813 22.5710166673 1.28492929317 -5.12203981813 32.0615652634 1.28492929317 -5.12303981813 0.122868952718 1.28492929317 -5.12403981813 32.3009488166 1.28492929317 -5.12503981813 33.7838963584 1.28492929317 -5.12603981813 23.2068641266 1.28492929317 -5.12703981813 18.6733083207 1.28492929317 -5.12803981813 28.3501081296 1.28492929317 -5.12903981813 15.6798502546 1.28492929317 -5.13003981813 22.5342067156 1.28492929317 -5.13103981813 13.3877693288 1.28492929317 -5.13203981813 14.2087181396 1.28492929317 -5.13303981813 12.6379851155 1.28492929317 -5.13403981813 11.7111091965 1.28492929317 -5.13503981813 11.323338478 1.28492929317 -5.13603981813 13.1133386127 1.28492929317 -5.13703981813 7.54055543569 1.28492929317 -5.13803981813 11.2675704569 1.28492929317 -5.13903981813 18.2317485895 1.28492929317 -5.14003981813 18.8824514255 1.28492929317 -5.14103981813 9.01694910312 1.28492929317 -5.14203981813 7.18401174763 1.28492929317 -5.14303981813 4.17600482449 1.28492929317 -5.14403981813 8.63307038113 1.28492929317 -5.14503981813 4.31520917855 1.28492929317 -5.14603981813 8.01047962577 1.28492929317 -5.14703981813 0.632110771294 1.28492929317 -5.14803981813 16.0788846386 1.28492929317 -5.14903981813 2.33783668581 1.28492929317 -5.15003981813 1.601350138 1.28492929317 -5.15103981813 -4.71249071387 1.28492929317 -5.15203981813 10.0129156721 1.28492929317 -5.15303981813 -6.84282196272 1.28492929317 -5.15403981813 -8.63995943136 1.28492929317 -5.15503981813 -1.52195947616 1.28492929317 -5.15603981813 -5.22373724382 1.28492929317 -5.15703981813 -14.3579460913 1.28492929317 -5.15803981813 -6.95260602823 1.28492929317 -5.15903981813 -13.044070874 1.28492929317 -5.16003981813 -18.6376339594 1.28492929317 -5.16103981813 -15.4625277277 1.28492929317 -5.16203981813 -14.0802924149 1.28492929317 -5.16303981813 -19.9292008332 1.28492929317 -5.16403981813 -14.0257873405 1.28492929317 -5.16503981813 -16.2863494488 1.28492929317 -5.16603981813 -25.1022069135 1.28492929317 -5.16703981813 -18.7281277956 1.28492929317 -5.16803981813 -21.0521923541 1.28492929317 -5.16903981813 -23.6252728513 1.28492929317 -5.17003981813 -24.82161396 1.28492929317 -5.17103981813 -27.4052031947 1.28492929317 -5.17203981813 -26.9732781349 1.28492929317 -5.17303981813 -27.3421912653 1.28492929317 -5.17403981813 -27.5678713641 1.28492929317 -5.17503981813 -29.1418853845 1.28492929317 -5.17603981813 -30.0593635411 1.28492929317 -5.17703981813 -31.9820146236 1.28492929317 -5.17803981813 -33.9114779226 1.28492929317 -5.17903981813 -33.8425876286 1.28492929317 -5.18003981813 -33.8425876286 1.28492929317 -5.18103981813 -33.8425876286 1.28492929317 -5.18203981813 -33.8425876286 1.28492929317 -5.18303981813 -33.8425876286 1.28492929317 -5.18403981813 -33.8425876286 1.28492929317 -5.18503981813 -33.8425876286 1.28492929317 -5.18603981813 -33.8425876286 1.28492929317 -5.18703981813 -33.8425876286 1.28492929317 -5.18803981813 -33.8425876286 1.28492929317 -5.18903981813 -33.8425876286 1.28492929317 -5.19003981813 -33.8425876286 1.28492929317 -5.19103981813 -33.8425876286 1.28492929317 -5.19203981813 -33.8425876286 1.28492929317 -5.19303981813 -33.8425876286 1.28492929317 -5.19403981813 -33.8425876286 1.28492929317 -5.19503981813 -33.8425876286 1.28492929317 -5.19603981813 -33.8425876286 1.28492929317 -5.19703981813 -33.8425876286 1.28492929317 -5.19803981813 -33.8425876286 1.28492929317 -5.19903981813 -33.8425876286 1.28492929317 -5.20003981813 -33.8425876286 1.28492929317 -5.20103981813 -33.8425876286 1.28492929317 -5.20203981813 -33.8425876286 1.28492929317 -5.20303981813 -33.8425876286 1.28492929317 -5.20403981813 -33.8425876286 1.28492929317 -5.20503981813 -33.8425876286 1.28492929317 -5.20603981813 -33.8425876286 1.28492929317 -5.20703981813 -33.8425876286 1.28492929317 -5.20803981813 -33.8425876286 1.28492929317 -5.20903981813 -33.8425876286 1.28492929317 -5.21003981813 -33.8425876286 1.28492929317 -5.21103981813 -33.8425876286 1.28492929317 -5.21203981813 -33.8425876286 1.28492929317 -5.21303981813 -33.8425876286 1.28492929317 -5.21403981813 -33.8425876286 1.28492929317 -5.21503981813 -33.8425876286 1.28492929317 -5.21603981813 -33.8425876286 1.28492929317 -5.21703981813 -33.8425876286 1.28492929317 -5.21803981813 -33.8425876286 1.28492929317 -5.21903981813 -33.8425876286 1.28492929317 -5.22003981813 -33.8425876286 1.28492929317 -5.22103981813 -33.8425876286 1.28492929317 -5.22203981813 -33.8425876286 1.28492929317 -5.22303981813 -33.8425876286 1.28492929317 -5.22403981813 -33.8425876286 1.28492929317 -5.22503981813 -33.8425876286 1.28492929317 -5.22603981813 -33.8425876286 1.28492929317 -5.22703981813 -33.8425876286 1.28492929317 -5.22803981813 -33.8425876286 1.28492929317 -5.22903981813 -33.8425876286 1.28492929317 -5.23003981813 -33.8425876286 1.28492929317 -5.23103981813 -33.8425876286 1.28492929317 -5.23203981813 -33.8425876286 1.28492929317 -5.23303981813 -33.8425876286 1.28492929317 -5.23403981813 -33.8425876286 1.28492929317 -5.23503981813 -33.8425876286 1.28492929317 -5.23603981813 -33.8425876286 1.28492929317 -5.23703981813 -33.8425876286 1.28492929317 -5.23803981813 -33.8425876286 1.28492929317 -5.23903981813 -33.8425876286 1.28492929317 -5.24003981813 -33.8425876286 1.28492929317 -5.24103981813 -33.8425876286 1.28492929317 -5.24203981813 -33.8425876286 1.28492929317 -5.24303981813 -33.8425876286 1.28492929317 -5.24403981813 -33.8425876286 1.28492929317 -5.24503981813 -33.8425876286 1.28492929317 -5.24603981813 -33.8425876286 1.28492929317 -5.24703981813 -33.8425876286 1.28492929317 -5.24803981813 -33.8425876286 1.28492929317 -5.24903981813 -33.8425876286 1.28492929317 -5.25003981813 -33.8425876286 1.28492929317 -5.25103981813 -33.8425876286 1.28492929317 -5.25203981813 -33.8425876286 1.28492929317 -5.25303981813 -33.8425876286 1.28492929317 -5.25403981813 -33.8425876286 1.28492929317 -5.25503981813 -33.8425876286 1.28492929317 -5.25603981813 -33.8425876286 1.28492929317 -5.25703981813 -33.8425876286 1.28492929317 -5.25803981813 -33.8425876286 1.28492929317 -5.25903981813 -33.8425876286 1.28492929317 -5.26003981813 -33.8425876286 1.28492929317 -5.26103981813 -33.8425876286 1.28492929317 -5.26203981813 -33.8425876286 1.28492929317 -5.26303981813 -33.8425876286 1.28492929317 -5.26403981813 -33.8425876286 1.28492929317 -5.26503981813 -33.8425876286 1.28492929317 -5.26603981813 -33.8425876286 1.28492929317 -5.26703981813 -33.8425876286 1.28492929317 -5.26803981813 -33.8425876286 1.28492929317 -5.26903981813 -33.8425876286 1.28492929317 -5.27003981813 -33.8425876286 1.28492929317 -5.27103981813 -33.8425876286 1.28492929317 -5.27203981813 -33.8425876286 1.28492929317 -5.27303981813 -33.8425876286 1.28492929317 -5.27403981813 -33.8425876286 1.28492929317 -5.27503981813 -33.8425876286 1.28492929317 -5.27603981813 -33.8425876286 1.28492929317 -5.27703981813 -33.8425876286 1.28492929317 -5.27803981813 -33.8425876286 1.28492929317 -5.27903981813 -33.8425876286 1.28492929317 -5.28003981813 -33.8425876286 1.28492929317 -5.28103981813 -33.8425876286 1.28492929317 -5.28203981813 -33.8425876286 1.28492929317 -5.28303981813 -33.8425876286 1.28492929317 -5.28403981813 -33.8425876286 1.28492929317 -5.28503981813 -33.8425876286 1.28492929317 -5.28603981813 -33.8425876286 1.28492929317 -5.28703981813 -33.8425876286 1.28492929317 -5.28803981813 -33.8425876286 1.28492929317 -5.28903981813 -33.8425876286 1.28492929317 -5.29003981813 -33.8425876286 1.28492929317 -5.29103981813 -33.8425876286 1.28492929317 -5.29203981813 -33.8425876286 1.28492929317 -5.29303981813 -33.8425876286 1.28492929317 -5.29403981813 -33.8425876286 1.28492929317 -5.29503981813 -33.8425876286 1.28492929317 -5.29603981813 -33.8425876286 1.28492929317 -5.29703981813 -33.8425876286 1.28492929317 -5.29803981813 -33.8425876286 1.28492929317 -5.29903981813 -33.8425876286 1.28492929317 -5.30003981813 -33.8425876286 1.28492929317 -5.30103981813 -33.8425876286 1.28492929317 -5.30203981813 -33.8425876286 1.28492929317 -5.30303981813 -33.8425876286 1.28492929317 -5.30403981813 -33.8425876286 1.28492929317 -5.30503981813 -33.8425876286 1.28492929317 -5.30603981813 -33.8425876286 1.28492929317 -5.30703981813 -33.8425876286 1.28492929317 -5.30803981813 -33.8425876286 1.28492929317 -5.30903981813 -33.8425876286 1.28492929317 -5.31003981813 -33.8425876286 1.28492929317 -5.31103981813 -33.8425876286 1.28492929317 -5.31203981813 -33.8425876286 1.28492929317 -5.31303981813 -33.8425876286 1.28492929317 -5.31403981813 -33.8425876286 1.28492929317 -5.31503981813 -33.8425876286 1.28492929317 -5.31603981813 -33.8425876286 1.28492929317 -5.31703981813 -33.8425876286 1.28492929317 -5.31803981813 -33.8425876286 1.28492929317 -5.31903981813 -33.8425876286 1.28492929317 -5.32003981813 -33.8425876286 1.28492929317 -5.32103981813 -33.8425876286 1.28492929317 -5.32203981813 -33.8425876286 1.28492929317 -5.32303981813 -33.8425876286 1.28492929317 -5.32403981813 -33.8425876286 1.28492929317 -5.32503981813 -33.8425876286 1.28492929317 -5.32603981813 -33.8425876286 1.28492929317 -5.32703981813 -33.8425876286 1.28492929317 -5.32803981813 -33.8425876286 1.28492929317 -5.32903981813 -33.8425876286 1.28492929317 -5.33003981813 -33.8425876286 1.28492929317 -5.33103981813 -33.8425876286 1.28492929317 -5.33203981813 -33.8425876286 1.28492929317 -5.33303981813 -33.8425876286 1.28492929317 -5.33403981813 -33.8425876286 1.28492929317 -5.33503981813 -33.8425876286 1.28492929317 -5.33603981813 -33.8425876286 1.28492929317 -5.33703981813 -33.8425876286 1.28492929317 -5.33803981813 -33.8425876286 1.28492929317 -5.33903981813 -33.8425876286 1.28492929317 -5.34003981813 -33.8425876286 1.28492929317 -5.34103981813 -33.8425876286 1.28492929317 -5.34203981813 -33.8425876286 1.28492929317 -5.34303981813 -33.8425876286 1.28492929317 -5.34403981813 -33.8425876286 1.28492929317 -5.34503981813 -33.8425876286 1.28492929317 -5.34603981813 -33.8425876286 1.28492929317 -5.34703981813 -33.8425876286 1.28492929317 -5.34803981813 -33.8425876286 1.28492929317 -5.34903981813 -33.8425876286 1.28492929317 -5.35003981813 -33.8425876286 1.28492929317 -5.35103981813 -33.8425876286 1.28492929317 -5.35203981813 -33.8425876286 1.28492929317 -5.35303981813 -33.8425876286 1.28492929317 -5.35403981813 -33.8425876286 1.28492929317 -5.35503981813 -33.8425876286 1.28492929317 -5.35603981813 -33.8425876286 1.28492929317 -5.35703981813 -33.8425876286 1.28492929317 -5.35803981813 -33.8425876286 1.28492929317 -5.35903981813 -33.8425876286 1.28492929317 -5.36003981813 -33.8425876286 1.28492929317 -5.36103981813 -33.8425876286 1.28492929317 -5.36203981813 -33.8425876286 1.28492929317 -5.36303981813 -33.8425876286 1.28492929317 -5.36403981813 -33.8425876286 1.28492929317 -5.36503981813 -33.8425876286 1.28492929317 -5.36603981813 -33.8425876286 1.28492929317 -5.36703981813 -33.8425876286 1.28492929317 -5.36803981813 -33.8425876286 1.28492929317 -5.36903981813 -33.8425876286 1.28492929317 -5.37003981813 -33.8425876286 1.28492929317 -5.37103981813 -33.8425876286 1.28492929317 -5.37203981813 -33.8425876286 1.28492929317 -5.37303981813 -33.8425876286 1.28492929317 -5.37403981813 -33.8425876286 1.28492929317 -5.37503981813 -33.8425876286 1.28492929317 -5.37603981813 -33.8425876286 1.28492929317 -5.37703981813 -33.8425876286 1.28492929317 -5.37803981813 -33.8425876286 1.28492929317 -5.37903981813 -33.8425876286 1.28492929317 -5.38003981813 -33.8425876286 1.28492929317 -5.38103981813 -33.8425876286 1.28492929317 -5.38203981813 -33.8425876286 1.28492929317 -5.38303981813 -33.8425876286 1.28492929317 -5.38403981813 -33.8425876286 1.28492929317 -5.38503981813 -33.8425876286 1.28492929317 -5.38603981813 -33.8425876286 1.28492929317 -5.38703981813 -33.8425876286 1.28492929317 -5.38803981813 -33.8425876286 1.28492929317 -5.38903981813 -33.8425876286 1.28492929317 -5.39003981813 -33.8425876286 1.28492929317 -5.39103981813 -33.8425876286 1.28492929317 -5.39203981813 -33.8425876286 1.28492929317 -5.39303981813 -33.8425876286 1.28492929317 -5.39403981813 -33.8425876286 1.28492929317 -5.39503981813 -33.8425876286 1.28492929317 -5.39603981813 -33.8425876286 1.28492929317 -5.39703981813 -33.8425876286 1.28492929317 -5.39803981813 -33.8425876286 1.28492929317 -5.39903981813 -33.8425876286 1.28492929317 -5.40003981813 -33.8425876286 1.28492929317 -5.40103981813 -33.8425876286 1.28492929317 -5.40203981813 -33.8425876286 1.28492929317 -5.40303981813 -33.8425876286 1.28492929317 -5.40403981813 -33.8425876286 1.28492929317 -5.40503981813 -33.8425876286 1.28492929317 -5.40603981813 -33.8425876286 1.28492929317 -5.40703981813 -33.8425876286 1.28492929317 -5.40803981813 -33.8425876286 1.28492929317 -5.40903981813 -33.8425876286 1.28492929317 -5.41003981813 -33.8425876286 1.28492929317 -5.41103981813 -33.8425876286 1.28492929317 -5.41203981813 -33.8425876286 1.28492929317 -5.41303981813 -33.8425876286 1.28492929317 -5.41403981813 -33.8425876286 1.28492929317 -5.41503981813 -33.8425876286 1.28492929317 -5.41603981813 -33.8425876286 1.28492929317 -5.41703981813 -33.8425876286 1.28492929317 -5.41803981813 -33.8425876286 1.28492929317 -5.41903981813 -33.8425876286 1.28492929317 -5.42003981813 -33.8425876286 1.28492929317 -5.42103981813 -33.8425876286 1.28492929317 -5.42203981813 -33.8425876286 1.28492929317 -5.42303981813 -33.8425876286 1.28492929317 -5.42403981813 -33.8425876286 1.28492929317 -5.42503981813 -33.8425876286 1.28492929317 -5.42603981813 -33.8425876286 1.28492929317 -5.42703981813 -33.8425876286 1.28492929317 -5.42803981813 -33.8425876286 1.28492929317 -5.42903981813 -33.8425876286 1.28492929317 -5.43003981813 -33.8425876286 1.28492929317 -5.43103981813 -33.8425876286 1.28492929317 -5.43203981813 -33.8425876286 1.28492929317 -5.43303981813 -33.8425876286 1.28492929317 -5.43403981813 -33.8425876286 1.28492929317 -5.43503981813 -33.8425876286 1.28492929317 -5.43603981813 -33.8425876286 1.28492929317 -5.43703981813 -33.8425876286 1.28492929317 -5.43803981813 -33.8425876286 1.28492929317 -5.43903981813 -33.8425876286 1.28492929317 -5.44003981813 -33.8425876286 1.28492929317 -5.44103981813 -33.8425876286 1.28492929317 -5.44203981813 -33.8425876286 1.28492929317 -5.44303981813 -33.8425876286 1.28492929317 -5.44403981813 -33.8425876286 1.28492929317 -5.44503981813 -33.8425876286 1.28492929317 -5.44603981813 -33.8425876286 1.28492929317 -5.44703981813 -33.8425876286 1.28492929317 -5.44803981813 -33.8425876286 1.28492929317 -5.44903981813 -33.8425876286 1.28492929317 -5.45003981813 -33.8425876286 1.28492929317 -5.45103981813 -33.8425876286 1.28492929317 -5.45203981813 -33.8425876286 1.28492929317 -5.45303981813 -33.8425876286 1.28492929317 -5.45403981813 -33.8425876286 1.28492929317 -5.45503981813 -33.8425876286 1.28492929317 -5.45603981813 -33.8425876286 1.28492929317 -5.45703981813 -33.8425876286 1.28492929317 -5.45803981813 -33.8425876286 1.28492929317 -5.45903981813 -33.8425876286 1.28492929317 -5.46003981813 -33.8425876286 1.28492929317 -5.46103981813 -33.8425876286 1.28492929317 -5.46203981813 -33.8425876286 1.28492929317 -5.46303981813 -33.8425876286 1.28492929317 -5.46403981813 -33.8425876286 1.28492929317 -5.46503981813 -33.8425876286 1.28492929317 -5.46603981813 -33.8425876286 1.28492929317 -5.46703981813 -33.8425876286 1.28492929317 -5.46803981813 -33.8425876286 1.28492929317 -5.46903981813 -33.8425876286 1.28492929317 -5.47003981813 -33.8425876286 1.28492929317 -5.47103981813 -33.8425876286 1.28492929317 -5.47203981813 -33.8425876286 1.28492929317 -5.47303981813 -33.8425876286 1.28492929317 -5.47403981813 -33.8425876286 1.28492929317 -5.47503981813 -33.8425876286 1.28492929317 -5.47603981813 -33.8425876286 1.28492929317 -5.47703981813 -33.8425876286 1.28492929317 -5.47803981813 -33.8425876286 1.28492929317 -5.47903981813 -33.8425876286 1.28492929317 -5.48003981813 -33.8425876286 1.28492929317 -5.48103981813 -33.8425876286 1.28492929317 -5.48203981813 -33.8425876286 1.28492929317 -5.48303981813 -33.8425876286 1.28492929317 -5.48403981813 -33.8425876286 1.28492929317 -5.48503981813 -33.8425876286 1.28492929317 -5.48603981813 -33.8425876286 1.28492929317 -5.48703981813 -33.8425876286 1.28492929317 -5.48803981813 -33.8425876286 1.28492929317 -5.48903981813 -33.8425876286 1.28492929317 -5.49003981813 -33.8425876286 1.28492929317 -5.49103981813 -33.8425876286 1.28492929317 -5.49203981813 -33.8425876286 1.28492929317 -5.49303981813 -33.8425876286 1.28492929317 -5.49403981813 -33.8425876286 1.28492929317 -5.49503981813 -33.8425876286 1.28492929317 -5.49603981813 -33.8425876286 1.28492929317 -5.49703981813 -33.8425876286 1.28492929317 -5.49803981813 -33.8425876286 1.28492929317 -5.49903981813 -33.8425876286 1.28492929317 -5.50003981813 -33.8425876286 1.28492929317 -5.50103981813 -33.8425876286 1.28492929317 -5.50203981813 -33.8425876286 1.28492929317 -5.50303981813 -33.8425876286 1.28492929317 -5.50403981813 -33.8425876286 1.28492929317 -5.50503981813 -33.8425876286 1.28492929317 -5.50603981813 -33.8425876286 1.28492929317 -5.50703981813 -33.8425876286 1.28492929317 -5.50803981813 -33.8425876286 1.28492929317 -5.50903981813 -33.8425876286 1.28492929317 -5.51003981813 -33.8425876286 1.28492929317 -5.51103981813 -33.8425876286 1.28492929317 -5.51203981813 -33.8425876286 1.28492929317 -5.51303981813 -33.8425876286 1.28492929317 -5.51403981813 -33.8425876286 1.28492929317 -5.51503981813 -33.8425876286 1.28492929317 -5.51603981813 -33.8425876286 1.28492929317 -5.51703981813 -33.8425876286 1.28492929317 -5.51803981813 -33.8425876286 1.28492929317 -5.51903981813 -33.8425876286 1.28492929317 -5.52003981813 -33.8425876286 1.28492929317 -5.52103981813 -33.8425876286 1.28492929317 -5.52203981813 -33.8425876286 1.28492929317 -5.52303981813 -33.8425876286 1.28492929317 -5.52403981813 -33.8425876286 1.28492929317 -5.52503981813 -33.8425876286 1.28492929317 -5.52603981813 -33.8425876286 1.28492929317 -5.52703981813 -33.8425876286 1.28492929317 -5.52803981813 -33.8425876286 1.28492929317 -5.52903981813 -33.8425876286 1.28492929317 -5.53003981813 -33.8425876286 1.28492929317 -5.53103981813 -33.8425876286 1.28492929317 -5.53203981813 -33.8425876286 1.28492929317 -5.53303981813 -33.8425876286 1.28492929317 -5.53403981813 -33.8425876286 1.28492929317 -5.53503981813 -33.8425876286 1.28492929317 -5.53603981813 -33.8425876286 1.28492929317 -5.53703981813 -33.8425876286 1.28492929317 -5.53803981813 -33.8425876286 1.28492929317 -5.53903981813 -33.8425876286 1.28492929317 -5.54003981813 -33.8425876286 1.28492929317 -5.54103981813 -33.8425876286 1.28492929317 -5.54203981813 -33.8425876286 1.28492929317 -5.54303981813 -33.8425876286 1.28492929317 -5.54403981813 -33.8425876286 1.28492929317 -5.54503981813 -33.8425876286 1.28492929317 -5.54603981813 -33.8425876286 1.28492929317 -5.54703981813 -33.8425876286 1.28492929317 -5.54803981813 -33.8425876286 1.28492929317 -5.54903981813 -33.8425876286 1.28492929317 -5.55003981813 -33.8425876286 1.28492929317 -5.55103981813 -33.8425876286 1.28492929317 -5.55203981813 -33.8425876286 1.28492929317 -5.55303981813 -33.8425876286 1.28492929317 -5.55403981813 -33.8425876286 1.28492929317 -5.55503981813 -33.8425876286 1.28492929317 -5.55603981813 -33.8425876286 1.28492929317 -5.55703981813 -33.8425876286 1.28492929317 -5.55803981813 -33.8425876286 1.28492929317 -5.55903981813 -33.8425876286 1.28492929317 -5.56003981813 -33.8425876286 1.28492929317 -5.56103981813 -33.8425876286 1.28492929317 -5.56203981813 -33.8425876286 1.28492929317 -5.56303981813 -33.8425876286 1.28492929317 -5.56403981813 -33.8425876286 1.28492929317 -5.56503981813 -33.8425876286 1.28492929317 -5.56603981813 -33.8425876286 1.28492929317 -5.56703981813 -33.8425876286 1.28492929317 -5.56803981813 -33.8425876286 1.28492929317 -5.56903981813 -33.8425876286 1.28492929317 -5.57003981813 -33.8425876286 1.28492929317 -5.57103981813 -33.8425876286 1.28492929317 -5.57203981813 -33.8425876286 1.28492929317 -5.57303981813 -33.8425876286 1.28492929317 -5.57403981813 -33.8425876286 1.28492929317 -5.57503981813 -33.8425876286 1.28492929317 -5.57603981813 -33.8425876286 1.28492929317 -5.57703981813 -33.8425876286 1.28492929317 -5.57803981813 -33.8425876286 1.28492929317 -5.57903981813 -33.8425876286 1.28492929317 -5.58003981813 -33.8425876286 1.28492929317 -5.58103981813 -33.8425876286 1.28492929317 -5.58203981813 -33.8425876286 1.28492929317 -5.58303981813 -33.8425876286 1.28492929317 -5.58403981813 -33.8425876286 1.28492929317 -5.58503981813 -33.8425876286 1.28492929317 -5.58603981813 -33.8425876286 1.28492929317 -5.58703981813 -33.8425876286 1.28492929317 -5.58803981813 -33.8425876286 1.28492929317 -5.58903981813 -33.8425876286 1.28492929317 -5.59003981813 -33.8425876286 1.28492929317 -5.59103981813 -33.8425876286 1.28492929317 -5.59203981813 -33.8425876286 1.28492929317 -5.59303981813 -33.8425876286 1.28492929317 -5.59403981813 -33.8425876286 1.28492929317 -5.59503981813 -33.8425876286 1.28492929317 -5.59603981813 -33.8425876286 1.28492929317 -5.59703981813 -33.8425876286 1.28492929317 -5.59803981813 -33.8425876286 1.28492929317 -5.59903981813 -33.8425876286 1.28492929317 -5.60003981813 -33.8425876286 1.28492929317 -5.60103981813 -33.8425876286 1.28492929317 -5.60203981813 -33.8425876286 1.28492929317 -5.60303981813 -33.8425876286 1.28492929317 -5.60403981813 -33.8425876286 1.28492929317 -5.60503981813 -33.8425876286 1.28492929317 -5.60603981813 -33.8425876286 1.28492929317 -5.60703981813 -33.8425876286 1.28492929317 -5.60803981813 -33.8425876286 1.28492929317 -5.60903981813 -33.8425876286 1.28492929317 -5.61003981813 -33.8425876286 1.28492929317 -5.61103981813 -33.8425876286 1.28492929317 -5.61203981813 -33.8425876286 1.28492929317 -5.61303981813 -33.8425876286 1.28492929317 -5.61403981813 -33.8425876286 1.28492929317 -5.61503981813 -33.8425876286 1.28492929317 -5.61603981813 -33.8425876286 1.28492929317 -5.61703981813 -33.8425876286 1.28492929317 -5.61803981813 -33.8425876286 1.28492929317 -5.61903981813 -33.8425876286 1.28492929317 -5.62003981813 -33.8425876286 1.28492929317 -5.62103981813 -33.8425876286 1.28492929317 -5.62203981813 -33.8425876286 1.28492929317 -5.62303981813 -33.8425876286 1.28492929317 -5.62403981813 -33.8425876286 1.28492929317 -5.62503981813 -33.8425876286 1.28492929317 -5.62603981813 -33.8425876286 1.28492929317 -5.62703981813 -33.8425876286 1.28492929317 -5.62803981813 -33.8425876286 1.28492929317 -5.62903981813 -33.8425876286 1.28492929317 -5.63003981813 -33.8425876286 1.28492929317 -5.63103981813 -33.8425876286 1.28492929317 -5.63203981813 -33.8425876286 1.28492929317 -5.63303981813 -33.8425876286 1.28492929317 -5.63403981813 -33.8425876286 1.28492929317 -5.63503981813 -33.8425876286 1.28492929317 -5.63603981813 -33.8425876286 1.28492929317 -5.63703981813 -33.8425876286 1.28492929317 -5.63803981813 -33.8425876286 1.28492929317 -5.63903981813 -33.8425876286 1.28492929317 -5.64003981813 -33.8425876286 1.28492929317 -5.64103981813 -33.8425876286 1.28492929317 -5.64203981813 -33.8425876286 1.28492929317 -5.64303981813 -33.8425876286 1.28492929317 -5.64403981813 -33.8425876286 1.28492929317 -5.64503981813 -33.8425876286 1.28492929317 -5.64603981813 -33.8425876286 1.28492929317 -5.64703981813 -33.8425876286 1.28492929317 -5.64803981813 -33.8425876286 1.28492929317 -5.64903981813 -33.8425876286 1.28492929317 -5.65003981813 -33.8425876286 1.28492929317 -5.65103981813 -33.8425876286 1.28492929317 -5.65203981813 -33.8425876286 1.28492929317 -5.65303981813 -33.8425876286 1.28492929317 -5.65403981813 -33.8425876286 1.28492929317 -5.65503981813 -33.8425876286 1.28492929317 -5.65603981813 -33.8425876286 1.28492929317 -5.65703981813 -33.8425876286 1.28492929317 -5.65803981813 -33.8425876286 1.28492929317 -5.65903981813 -33.8425876286 1.28492929317 -5.66003981813 -33.8425876286 1.28492929317 -5.66103981813 -33.8425876286 1.28492929317 -5.66203981813 -33.8425876286 1.28492929317 -5.66303981813 -33.8425876286 1.28492929317 -5.66403981813 -33.8425876286 1.28492929317 -5.66503981813 -33.8425876286 1.28492929317 -5.66603981813 -33.8425876286 1.28492929317 -5.66703981813 -33.8425876286 1.28492929317 -5.66803981813 -33.8425876286 1.28492929317 -5.66903981813 -33.8425876286 1.28492929317 -5.67003981813 -33.8425876286 1.28492929317 -5.67103981813 -33.8425876286 1.28492929317 -5.67203981813 -33.8425876286 1.28492929317 -5.67303981813 -33.8425876286 1.28492929317 -5.67403981813 -33.8425876286 1.28492929317 -5.67503981813 -33.8425876286 1.28492929317 -5.67603981813 -33.8425876286 1.28492929317 -5.67703981813 -33.8425876286 1.28492929317 -5.67803981813 -33.8425876286 1.28492929317 -5.67903981813 -33.8425876286 1.28492929317 -5.68003981813 -33.8425876286 1.28492929317 -5.68103981813 -33.8425876286 1.28492929317 -5.68203981813 -33.8425876286 1.28492929317 -5.68303981813 -33.8425876286 1.28492929317 -5.68403981813 -33.8425876286 1.28492929317 -5.68503981813 -33.8425876286 1.28492929317 -5.68603981813 -33.8425876286 1.28492929317 -5.68703981813 -33.8425876286 1.28492929317 -5.68803981813 -33.8425876286 1.28492929317 -5.68903981813 -33.8425876286 1.28492929317 -5.69003981813 -33.8425876286 1.28492929317 -5.69103981813 -33.8425876286 1.28492929317 -5.69203981813 -33.8425876286 1.28492929317 -5.69303981813 -33.8425876286 1.28492929317 -5.69403981813 -33.8425876286 1.28492929317 -5.69503981813 -33.8425876286 1.28492929317 -5.69603981813 -33.8425876286 1.28492929317 -5.69703981813 -33.8425876286 1.28492929317 -5.69803981813 -33.8425876286 1.28492929317 -5.69903981813 -33.8425876286 1.28492929317 -5.70003981813 -33.8425876286 1.28492929317 -5.70103981813 -33.8425876286 1.28492929317 -5.70203981813 -33.8425876286 1.28492929317 -5.70303981813 -33.8425876286 1.28492929317 -5.70403981813 -33.8425876286 1.28492929317 -5.70503981813 -33.8425876286 1.28492929317 -5.70603981813 -33.8425876286 1.28492929317 -5.70703981813 -33.8425876286 1.28492929317 -5.70803981813 -33.8425876286 1.28492929317 -5.70903981813 -33.8425876286 1.28492929317 -5.71003981813 -33.8425876286 1.28492929317 -5.71103981813 -33.8425876286 1.28492929317 -5.71203981813 -33.8425876286 1.28492929317 -5.71303981813 -33.8425876286 1.28492929317 -5.71403981813 -33.8425876286 1.28492929317 -5.71503981813 -33.8425876286 1.28492929317 -5.71603981813 -33.8425876286 1.28492929317 -5.71703981813 -33.8425876286 1.28492929317 -5.71803981813 -33.8425876286 1.28492929317 -5.71903981813 -33.8425876286 1.28492929317 -5.72003981813 -33.8425876286 1.28492929317 -5.72103981813 -33.8425876286 1.28492929317 -5.72203981813 -33.8425876286 1.28492929317 -5.72303981813 -33.8425876286 1.28492929317 -5.72403981813 -33.8425876286 1.28492929317 -5.72503981813 -33.8425876286 1.28492929317 -5.72603981813 -33.8425876286 1.28492929317 -5.72703981813 -33.8425876286 1.28492929317 -5.72803981813 -33.8425876286 1.28492929317 -5.72903981813 -33.8425876286 1.28492929317 -5.73003981813 -33.8425876286 1.28492929317 -5.73103981813 -33.8425876286 1.28492929317 -5.73203981813 -33.8425876286 1.28492929317 -5.73303981813 -33.8425876286 1.28492929317 -5.73403981813 -33.8425876286 1.28492929317 -5.73503981813 -33.8425876286 1.28492929317 -5.73603981813 -33.8425876286 1.28492929317 -5.73703981813 -33.8425876286 1.28492929317 -5.73803981813 -33.8425876286 1.28492929317 -5.73903981813 -33.8425876286 1.28492929317 -5.74003981813 -33.8425876286 1.28492929317 -5.74103981813 -33.8425876286 1.28492929317 -5.74203981813 -33.8425876286 1.28492929317 -5.74303981813 -33.8425876286 1.28492929317 -5.74403981813 -33.8425876286 1.28492929317 -5.74503981813 -33.8425876286 1.28492929317 -5.74603981813 -33.8425876286 1.28492929317 -5.74703981813 -33.8425876286 1.28492929317 -5.74803981813 -33.8425876286 1.28492929317 -5.74903981813 -33.8425876286 1.28492929317 -5.75003981813 -33.8425876286 1.28492929317 -5.75103981813 -33.8425876286 1.28492929317 -5.75203981813 -33.8425876286 1.28492929317 -5.75303981813 -33.8425876286 1.28492929317 -5.75403981813 -33.8425876286 1.28492929317 -5.75503981813 -33.8425876286 1.28492929317 -5.75603981813 -33.8425876286 1.28492929317 -5.75703981813 -33.8425876286 1.28492929317 -5.75803981813 -33.8425876286 1.28492929317 -5.75903981813 -33.8425876286 1.28492929317 -5.76003981813 -33.8425876286 1.28492929317 -5.76103981813 -33.8425876286 1.28492929317 -5.76203981813 -33.8425876286 1.28492929317 -5.76303981813 -33.8425876286 1.28492929317 -5.76403981813 -33.8425876286 1.28492929317 -5.76503981813 -33.8425876286 1.28492929317 -5.76603981813 -33.8425876286 1.28492929317 -5.76703981813 -33.8425876286 1.28492929317 -5.76803981813 -33.8425876286 1.28492929317 -5.76903981813 -33.8425876286 1.28492929317 -5.77003981813 -33.8425876286 1.28492929317 -5.77103981813 -33.8425876286 1.28492929317 -5.77203981813 -33.8425876286 1.28492929317 -5.77303981813 -33.8425876286 1.28492929317 -5.77403981813 -33.8425876286 1.28492929317 -5.77503981813 -33.8425876286 1.28492929317 -5.77603981813 -33.8425876286 1.28492929317 -5.77703981813 -33.8425876286 1.28492929317 -5.77803981813 -33.8425876286 1.28492929317 -5.77903981813 -33.8425876286 1.28492929317 -5.78003981813 -33.8425876286 1.28492929317 -5.78103981813 -33.8425876286 1.28492929317 -5.78203981813 -33.8425876286 1.28492929317 -5.78303981813 -33.8425876286 1.28492929317 -5.78403981813 -33.8425876286 1.28492929317 -5.78503981813 -33.8425876286 1.28492929317 -5.78603981813 -33.8425876286 1.28492929317 -5.78703981813 -33.8425876286 1.28492929317 -5.78803981813 -33.8425876286 1.28492929317 -5.78903981813 -33.8425876286 1.28492929317 -5.79003981813 -33.8425876286 1.28492929317 -5.79103981813 -33.8425876286 1.28492929317 -5.79203981813 -33.8425876286 1.28492929317 -5.79303981813 -33.8425876286 1.28492929317 -5.79403981813 -33.8425876286 1.28492929317 -5.79503981813 -33.8425876286 1.28492929317 -5.79603981813 -33.8425876286 1.28492929317 -5.79703981813 -33.8425876286 1.28492929317 -5.79803981813 -33.8425876286 1.28492929317 -5.79903981813 -33.8425876286 1.28492929317 -5.80003981813 -33.8425876286 1.28492929317 -5.80103981813 -33.8425876286 1.28492929317 -5.80203981813 -33.8425876286 1.28492929317 -5.80303981813 -33.8425876286 1.28492929317 -5.80403981813 -33.8425876286 1.28492929317 -5.80503981813 -33.8425876286 1.28492929317 -5.80603981813 -33.8425876286 1.28492929317 -5.80703981813 -33.8425876286 1.28492929317 -5.80803981813 -33.8425876286 1.28492929317 -5.80903981813 -33.8425876286 1.28492929317 -5.81003981813 -33.8425876286 1.28492929317 -5.81103981813 -33.8425876286 1.28492929317 -5.81203981813 -33.8425876286 1.28492929317 -5.81303981813 -33.8425876286 1.28492929317 -5.81403981813 -33.8425876286 1.28492929317 -5.81503981813 -33.8425876286 1.28492929317 -5.81603981813 -33.8425876286 1.28492929317 -5.81703981813 -33.8425876286 1.28492929317 -5.81803981813 -33.8425876286 1.28492929317 -5.81903981813 -33.8425876286 1.28492929317 -5.82003981813 -33.8425876286 1.28492929317 -5.82103981813 -33.8425876286 1.28492929317 -5.82203981813 -33.8425876286 1.28492929317 -5.82303981813 -33.8425876286 1.28492929317 -5.82403981813 -33.8425876286 1.28492929317 -5.82503981813 -33.8425876286 1.28492929317 -5.82603981813 -33.8425876286 1.28492929317 -5.82703981813 -33.8425876286 1.28492929317 -5.82803981813 -33.8425876286 1.28492929317 -5.82903981813 -33.8425876286 1.28492929317 -5.83003981813 -33.8425876286 1.28492929317 -5.83103981813 -33.8425876286 1.28492929317 -5.83203981813 -33.8425876286 1.28492929317 -5.83303981813 -33.8425876286 1.28492929317 -5.83403981813 -33.8425876286 1.28492929317 -5.83503981813 -33.8425876286 1.28492929317 -5.83603981813 -33.8425876286 1.28492929317 -5.83703981813 -33.8425876286 1.28492929317 -5.83803981813 -33.8425876286 1.28492929317 -5.83903981813 -33.8425876286 1.28492929317 -5.84003981813 -33.8425876286 1.28492929317 -5.84103981813 -33.8425876286 1.28492929317 -5.84203981813 -33.8425876286 1.28492929317 -5.84303981813 -33.8425876286 1.28492929317 -5.84403981813 -33.8425876286 1.28492929317 -5.84503981813 -33.8425876286 1.28492929317 -5.84603981813 -33.8425876286 1.28492929317 -5.84703981813 -33.8425876286 1.28492929317 -5.84803981813 -33.8425876286 1.28492929317 -5.84903981813 -33.8425876286 1.28492929317 -5.85003981813 -33.8425876286 1.28492929317 -5.85103981813 -33.8425876286 1.28492929317 -5.85203981813 -33.8425876286 1.28492929317 -5.85303981813 -33.8425876286 1.28492929317 -5.85403981813 -33.8425876286 1.28492929317 -5.85503981813 -33.8425876286 1.28492929317 -5.85603981813 -33.8425876286 1.28492929317 -5.85703981813 -33.8425876286 1.28492929317 -5.85803981813 -33.8425876286 1.28492929317 -5.85903981813 -33.8425876286 1.28492929317 -5.86003981813 -33.8425876286 1.28492929317 -5.86103981813 -33.8425876286 1.28492929317 -5.86203981813 -33.8425876286 1.28492929317 -5.86303981813 -33.8425876286 1.28492929317 -5.86403981813 -33.8425876286 1.28492929317 -5.86503981813 -33.8425876286 1.28492929317 -5.86603981813 -33.8425876286 1.28492929317 -5.86703981813 -33.8425876286 1.28492929317 -5.86803981813 -33.8425876286 1.28492929317 -5.86903981813 -33.8425876286 1.28492929317 -5.87003981813 -33.8425876286 1.28492929317 -5.87103981813 -33.8425876286 1.28492929317 -5.87203981813 -33.8425876286 1.28492929317 -5.87303981813 -33.8425876286 1.28492929317 -5.87403981813 -33.8425876286 1.28492929317 -5.87503981813 -33.8425876286 1.28492929317 -5.87603981813 -33.8425876286 1.28492929317 -5.87703981813 -33.8425876286 1.28492929317 -5.87803981813 -33.8425876286 1.28492929317 -5.87903981813 -33.8425876286 1.28492929317 -5.88003981813 -33.8425876286 1.28492929317 -5.88103981813 -33.8425876286 1.28492929317 -5.88203981813 -33.8425876286 1.28492929317 -5.88303981813 -33.8425876286 1.28492929317 -5.88403981813 -33.8425876286 1.28492929317 -5.88503981813 -33.8425876286 1.28492929317 -5.88603981813 -33.8425876286 1.28492929317 -5.88703981813 -33.8425876286 1.28492929317 -5.88803981813 -33.8425876286 1.28492929317 -5.88903981813 -33.8425876286 1.28492929317 -5.89003981813 -33.8425876286 1.28492929317 -5.89103981813 -33.8425876286 1.28492929317 -5.89203981813 -33.8425876286 1.28492929317 -5.89303981813 -33.8425876286 1.28492929317 -5.89403981813 -33.8425876286 1.28492929317 -5.89503981813 -33.8425876286 1.28492929317 -5.89603981813 -33.8425876286 1.28492929317 -5.89703981813 -33.8425876286 1.28492929317 -5.89803981813 -33.8425876286 1.28492929317 -5.89903981813 -33.8425876286 1.28492929317 -5.90003981813 -33.8425876286 1.28492929317 -5.90103981813 -33.8425876286 1.28492929317 -5.90203981813 -33.8425876286 1.28492929317 -5.90303981813 -33.8425876286 1.28492929317 -5.90403981813 -33.8425876286 1.28492929317 -5.90503981813 -33.8425876286 1.28492929317 -5.90603981813 -33.8425876286 1.28492929317 -5.90703981813 -33.8425876286 1.28492929317 -5.90803981813 -33.8425876286 1.28492929317 -5.90903981813 -33.8425876286 1.28492929317 -5.91003981813 -33.8425876286 1.28492929317 -5.91103981813 -33.8425876286 1.28492929317 -5.91203981813 -33.8425876286 1.28492929317 -5.91303981813 -33.8425876286 1.28492929317 -5.91403981813 -33.8425876286 1.28492929317 -5.91503981813 -33.8425876286 1.28492929317 -5.91603981813 -33.8425876286 1.28492929317 -5.91703981813 -33.8425876286 1.28492929317 -5.91803981813 -33.8425876286 1.28492929317 -5.91903981813 -33.8425876286 1.28492929317 -5.92003981813 -33.8425876286 1.28492929317 -5.92103981813 -33.8425876286 1.28492929317 -5.92203981813 -33.8425876286 1.28492929317 -5.92303981813 -33.8425876286 1.28492929317 -5.92403981813 -33.8425876286 1.28492929317 -5.92503981813 -33.8425876286 1.28492929317 -5.92603981813 -33.8425876286 1.28492929317 -5.92703981813 -33.8425876286 1.28492929317 -5.92803981813 -33.8425876286 1.28492929317 -5.92903981813 -33.8425876286 1.28492929317 -5.93003981813 -33.8425876286 1.28492929317 -5.93103981813 -33.8425876286 1.28492929317 -5.93203981813 -33.8425876286 1.28492929317 -5.93303981813 -33.8425876286 1.28492929317 -5.93403981813 -33.8425876286 1.28492929317 -5.93503981813 -33.8425876286 1.28492929317 -5.93603981813 -33.8425876286 1.28492929317 -5.93703981813 -33.8425876286 1.28492929317 -5.93803981813 -33.8425876286 1.28492929317 -5.93903981813 -33.8425876286 1.28492929317 -5.94003981813 -33.8425876286 1.28492929317 -5.94103981813 -33.8425876286 1.28492929317 -5.94203981813 -33.8425876286 1.28492929317 -5.94303981813 -33.8425876286 1.28492929317 -5.94403981813 -33.8425876286 1.28492929317 -5.94503981813 -33.8425876286 1.28492929317 -5.94603981813 -33.8425876286 1.28492929317 -5.94703981813 -33.8425876286 1.28492929317 -5.94803981813 -33.8425876286 1.28492929317 -5.94903981813 -33.8425876286 1.28492929317 -5.95003981813 -33.8425876286 1.28492929317 -5.95103981813 -33.8425876286 1.28492929317 -5.95203981813 -33.8425876286 1.28492929317 -5.95303981813 -33.8425876286 1.28492929317 -5.95403981813 -33.8425876286 1.28492929317 -5.95503981813 -33.8425876286 1.28492929317 -5.95603981813 -33.8425876286 1.28492929317 -5.95703981813 -33.8425876286 1.28492929317 -5.95803981813 -33.8425876286 1.28492929317 -5.95903981813 -33.8425876286 1.28492929317 -5.96003981813 -33.8425876286 1.28492929317 -5.96103981813 -33.8425876286 1.28492929317 -5.96203981813 -33.8425876286 1.28492929317 -5.96303981813 -33.8425876286 1.28492929317 -5.96403981813 -33.8425876286 1.28492929317 -5.96503981813 -33.8425876286 1.28492929317 -5.96603981813 -33.8425876286 1.28492929317 -5.96703981813 -33.8425876286 1.28492929317 -5.96803981813 -33.8425876286 1.28492929317 -5.96903981813 -33.8425876286 1.28492929317 -5.97003981813 -33.8425876286 1.28492929317 -5.97103981813 -33.8425876286 1.28492929317 -5.97203981813 -33.8425876286 1.28492929317 -5.97303981813 -33.8425876286 1.28492929317 -5.97403981813 -33.8425876286 1.28492929317 -5.97503981813 -33.8425876286 1.28492929317 -5.97603981813 -33.8425876286 1.28492929317 -5.97703981813 -33.8425876286 1.28492929317 -5.97803981813 -33.8425876286 1.28492929317 -5.97903981813 -33.8425876286 1.28492929317 -5.98003981813 -33.8425876286 1.28492929317 -5.98103981813 -33.8425876286 1.28492929317 -5.98203981813 -33.8425876286 1.28492929317 -5.98303981813 -33.8425876286 1.28492929317 -5.98403981813 -33.8425876286 1.28492929317 -5.98503981813 -33.8425876286 1.28492929317 -5.98603981813 -33.8425876286 1.28492929317 -5.98703981813 -33.8425876286 1.28492929317 -5.98803981813 -33.8425876286 1.28492929317 -5.98903981813 -33.8425876286 1.28492929317 -5.99003981813 -33.8425876286 1.28492929317 -5.99103981813 -33.8425876286 1.28492929317 -5.99203981813 -33.8425876286 1.28492929317 -5.99303981813 -33.8425876286 1.28492929317 -5.99403981813 -33.8425876286 1.28492929317 -5.99503981813 -33.8425876286 1.28492929317 -5.99603981813 -33.8425876286 1.28492929317 -5.99703981813 -33.8425876286 1.28492929317 -5.99803981813 -33.8425876286 1.28492929317 -5.99903981813 -33.8425876286 1.28492929317 -6.00003981813 -33.8425876286 1.28492929317 -6.00103981813 -33.8425876286 1.28492929317 -6.00203981813 -33.8425876286 1.28492929317 -6.00303981813 -33.8425876286 1.28492929317 -6.00403981813 -33.8425876286 1.28492929317 -6.00503981813 -33.8425876286 1.28492929317 -6.00603981813 -33.8425876286 1.28492929317 -6.00703981813 -33.8425876286 1.28492929317 -6.00803981813 -33.8425876286 1.28492929317 -6.00903981813 -33.8425876286 1.28492929317 -6.01003981813 -33.8425876286 1.28492929317 -6.01103981813 -33.8425876286 1.28492929317 -6.01203981813 -33.8425876286 1.28492929317 -6.01303981813 -33.8425876286 1.28492929317 -6.01403981813 -33.8425876286 1.28492929317 -6.01503981813 -33.8425876286 1.28492929317 -6.01603981813 -33.8425876286 1.28492929317 -6.01703981813 -33.8425876286 1.28492929317 -6.01803981813 -33.8425876286 1.28492929317 -6.01903981813 -33.8425876286 1.28492929317 -6.02003981813 -33.8425876286 1.28492929317 -6.02103981813 -33.8425876286 1.28492929317 -6.02203981813 -33.8425876286 1.28492929317 -6.02303981813 -33.8425876286 1.28492929317 -6.02403981813 -33.8425876286 1.28492929317 -6.02503981813 -33.8425876286 1.28492929317 -6.02603981813 -33.8425876286 1.28492929317 -6.02703981813 -33.8425876286 1.28492929317 -6.02803981813 -33.8425876286 1.28492929317 -6.02903981813 -33.8425876286 1.28492929317 -6.03003981813 -33.8425876286 1.28492929317 -6.03103981813 -33.8425876286 1.28492929317 -6.03203981813 -33.8425876286 1.28492929317 -6.03303981813 -33.8425876286 1.28492929317 -6.03403981813 -33.8425876286 1.28492929317 -6.03503981813 -33.8425876286 1.28492929317 -6.03603981813 -33.8425876286 1.28492929317 -6.03703981813 -33.8425876286 1.28492929317 -6.03803981813 -33.8425876286 1.28492929317 -6.03903981813 -33.8425876286 1.28492929317 -6.04003981813 -33.8425876286 1.28492929317 -6.04103981813 -33.8425876286 1.28492929317 -6.04203981813 -33.8425876286 1.28492929317 -6.04303981813 -33.8425876286 1.28492929317 -6.04403981813 -33.8425876286 1.28492929317 -6.04503981813 -33.8425876286 1.28492929317 -6.04603981813 -33.8425876286 1.28492929317 -6.04703981813 -33.8425876286 1.28492929317 -6.04803981813 -33.8425876286 1.28492929317 -6.04903981813 -33.8425876286 1.28492929317 -6.05003981813 -33.8425876286 1.28492929317 -6.05103981813 -33.8425876286 1.28492929317 -6.05203981813 -33.8425876286 1.28492929317 -6.05303981813 -33.8425876286 1.28492929317 -6.05403981813 -33.8425876286 1.28492929317 -6.05503981813 -33.8425876286 1.28492929317 -6.05603981813 -33.8425876286 1.28492929317 -6.05703981813 -33.8425876286 1.28492929317 -6.05803981813 -33.8425876286 1.28492929317 -6.05903981813 -33.8425876286 1.28492929317 -6.06003981813 -33.8425876286 1.28492929317 -6.06103981813 -33.8425876286 1.28492929317 -6.06203981813 -33.8425876286 1.28492929317 -6.06303981813 -33.8425876286 1.28492929317 -6.06403981813 -33.8425876286 1.28492929317 -6.06503981813 -33.8425876286 1.28492929317 -6.06603981813 -33.8425876286 1.28492929317 -6.06703981813 -33.8425876286 1.28492929317 -6.06803981813 -33.8425876286 1.28492929317 -6.06903981813 -33.8425876286 1.28492929317 -6.07003981813 -33.8425876286 1.28492929317 -6.07103981813 -33.8425876286 1.28492929317 -6.07203981813 -33.8425876286 1.28492929317 -6.07303981813 -33.8425876286 1.28492929317 -6.07403981813 -33.8425876286 1.28492929317 -6.07503981813 -33.8425876286 1.28492929317 -6.07603981813 -33.8425876286 1.28492929317 -6.07703981813 -33.8425876286 1.28492929317 -6.07803981813 -33.8425876286 1.28492929317 -6.07903981813 -33.8425876286 1.28492929317 -6.08003981813 -33.8425876286 1.28492929317 -6.08103981813 -33.8425876286 1.28492929317 -6.08203981813 -33.8425876286 1.28492929317 -6.08303981813 -33.8425876286 1.28492929317 -6.08403981813 -33.8425876286 1.28492929317 -6.08503981813 -33.8425876286 1.28492929317 -6.08603981813 -33.8425876286 1.28492929317 -6.08703981813 -33.8425876286 1.28492929317 -6.08803981813 -33.8425876286 1.28492929317 -6.08903981813 -33.8425876286 1.28492929317 -6.09003981813 -33.8425876286 1.28492929317 -6.09103981813 -33.8425876286 1.28492929317 -6.09203981813 -33.8425876286 1.28492929317 -6.09303981813 -33.8425876286 1.28492929317 -6.09403981813 -33.8425876286 1.28492929317 -6.09503981813 -33.8425876286 1.28492929317 -6.09603981813 -33.8425876286 1.28492929317 -6.09703981813 -33.8425876286 1.28492929317 -6.09803981813 -33.8425876286 1.28492929317 -6.09903981813 -33.8425876286 1.28492929317 -6.10003981813 -33.8425876286 1.28492929317 -6.10103981813 -33.8425876286 1.28492929317 -6.10203981813 -33.8425876286 1.28492929317 -6.10303981813 -33.8425876286 1.28492929317 -6.10403981813 -33.8425876286 1.28492929317 -6.10503981813 -33.8425876286 1.28492929317 -6.10603981813 -33.8425876286 1.28492929317 -6.10703981813 -33.8425876286 1.28492929317 -6.10803981813 -33.8425876286 1.28492929317 -6.10903981813 -33.8425876286 1.28492929317 -6.11003981813 -33.8425876286 1.28492929317 -6.11103981813 -33.8425876286 1.28492929317 -6.11203981813 -33.8425876286 1.28492929317 -6.11303981813 -33.8425876286 1.28492929317 -6.11403981813 -33.8425876286 1.28492929317 -6.11503981813 -33.8425876286 1.28492929317 -6.11603981813 -33.8425876286 1.28492929317 -6.11703981813 -33.8425876286 1.28492929317 -6.11803981813 -33.8425876286 1.28492929317 -6.11903981813 -33.8425876286 1.28492929317 -6.12003981813 -33.8425876286 1.28492929317 -6.12103981813 -33.8425876286 1.28492929317 -6.12203981813 -33.8425876286 1.28492929317 -6.12303981813 -33.8425876286 1.28492929317 -6.12403981813 -33.8425876286 1.28492929317 -6.12503981813 -33.8425876286 1.28492929317 -6.12603981813 -33.8425876286 1.28492929317 -6.12703981813 -33.8425876286 1.28492929317 -6.12803981813 -33.8425876286 1.28492929317 -6.12903981813 -33.8425876286 1.28492929317 -6.13003981813 -33.8425876286 1.28492929317 -6.13103981813 -33.8425876286 1.28492929317 -6.13203981813 -33.8425876286 1.28492929317 -6.13303981813 -33.8425876286 1.28492929317 -6.13403981813 -33.8425876286 1.28492929317 -6.13503981813 -33.8425876286 1.28492929317 -6.13603981813 -33.8425876286 1.28492929317 -6.13703981813 -33.8425876286 1.28492929317 -6.13803981813 -33.8425876286 1.28492929317 -6.13903981813 -33.8425876286 1.28492929317 -6.14003981813 -33.8425876286 1.28492929317 -6.14103981813 -33.8425876286 1.28492929317 -6.14203981813 -33.8425876286 1.28492929317 -6.14303981813 -33.8425876286 1.28492929317 -6.14403981813 -33.8425876286 1.28492929317 -6.14503981813 -33.8425876286 1.28492929317 -6.14603981813 -33.8425876286 1.28492929317 -6.14703981813 -33.8425876286 1.28492929317 -6.14803981813 -33.8425876286 1.28492929317 -6.14903981813 -33.8425876286 1.28492929317 -6.15003981813 -33.8425876286 1.28492929317 -6.15103981813 -33.8425876286 1.28492929317 -6.15203981813 -33.8425876286 1.28492929317 -6.15303981813 -33.8425876286 1.28492929317 -6.15403981813 -33.8425876286 1.28492929317 -6.15503981813 -33.8425876286 1.28492929317 -6.15603981813 -33.8425876286 1.28492929317 -6.15703981813 -33.8425876286 1.28492929317 -6.15803981813 -33.8425876286 1.28492929317 -6.15903981813 -33.8425876286 1.28492929317 -6.16003981813 -33.8425876286 1.28492929317 -6.16103981813 -33.8425876286 1.28492929317 -6.16203981813 -33.8425876286 1.28492929317 -6.16303981813 -33.8425876286 1.28492929317 -6.16403981813 3.41021065203 1.28492929317 -6.16503981813 0.948466317246 1.28492929317 -6.16603981813 0.933364019216 1.28492929317 -6.16703981813 1.56226511814 1.28492929317 -6.16803981813 3.06796947125 1.28492929317 -6.16903981813 1.15146878018 1.28492929317 -6.17003981813 1.16461984648 1.28492929317 -6.17103981813 1.66700117651 1.28492929317 -6.17203981813 1.29045193914 1.28492929317 -6.17303981813 2.21885648803 1.28492929317 -6.17403981813 1.81807315244 1.28492929317 -6.17503981813 1.81807315244 1.28492929317 -6.17603981813 1.81807315244 1.28492929317 -6.17703981813 1.81807315244 1.28492929317 -6.17803981813 1.81807315244 1.28492929317 -6.17903981813 1.81807315244 1.28492929317 -6.18003981813 1.81807315244 1.28492929317 -6.18103981813 1.81807315244 1.28492929317 -6.18203981813 1.81807315244 1.28492929317 -6.18303981813 1.81807315244 1.28492929317 -6.18403981813 1.81807315244 1.28492929317 -6.18503981813 1.81807315244 1.28492929317 -6.18603981813 1.81807315244 1.28492929317 -6.18703981813 1.81807315244 1.28492929317 -6.18803981813 1.81807315244 1.28492929317 -6.18903981813 1.81807315244 1.28492929317 -6.19003981813 1.81807315244 1.28492929317 -6.19103981813 1.81807315244 1.28492929317 -6.19203981813 1.81807315244 1.28492929317 -6.19303981813 1.81807315244 1.28492929317 -6.19403981813 1.81807315244 1.28492929317 -6.19503981813 1.81807315244 1.28492929317 -6.19603981813 1.81807315244 1.28492929317 -6.19703981813 1.81807315244 1.28492929317 -6.19803981813 1.81807315244 1.28492929317 -6.19903981813 1.81807315244 1.28492929317 -6.20003981813 1.81807315244 1.28492929317 -6.20103981813 1.81807315244 1.28492929317 -6.20203981813 1.81807315244 1.28492929317 -6.20303981813 1.81807315244 1.28492929317 -6.20403981813 1.81807315244 1.28492929317 -6.20503981813 1.81807315244 1.28492929317 -6.20603981813 1.81807315244 1.28492929317 -6.20703981813 1.81807315244 1.28492929317 -6.20803981813 1.81807315244 1.28492929317 -6.20903981813 1.81807315244 1.28492929317 -6.21003981813 1.81807315244 1.28492929317 -6.21103981813 1.81807315244 1.28492929317 -6.21203981813 1.81807315244 1.28492929317 -6.21303981813 1.81807315244 1.28492929317 -6.21403981813 1.81807315244 1.28492929317 -6.21503981813 1.81807315244 1.28492929317 -6.21603981813 1.81807315244 1.28492929317 -6.21703981813 1.81807315244 1.28492929317 -6.21803981813 1.81807315244 1.28492929317 -6.21903981813 1.81807315244 1.28492929317 -6.22003981813 1.81807315244 1.28492929317 -6.22103981813 1.81807315244 1.28492929317 -6.22203981813 1.81807315244 1.28492929317 -6.22303981813 1.81807315244 1.28492929317 -6.22403981813 1.81807315244 1.28492929317 -6.22503981813 1.81807315244 1.28492929317 -6.22603981813 1.81807315244 1.28492929317 -6.22703981813 1.81807315244 1.28492929317 -6.22803981813 -18.9535323995 1.28492929317 -6.22903981813 -173.584749321 1.28492929317 -6.23003981813 -122.875638093 1.28492929317 -6.23103981813 -19.3320080862 1.28492929317 -6.23203981813 -67.7795121638 1.28492929317 -6.23303981813 -47.0263983734 1.28492929317 -6.23403981813 271.725489232 1.28492929317 -6.23503981813 129.530239038 1.28492929317 -6.23603981813 262.465409116 1.28492929317 -6.23703981813 439.988091426 1.28492929317 -6.23803981813 536.652904834 1.28492929317 -6.23903981813 502.787942436 1.28492929317 -6.24003981813 680.981935787 1.28492929317 -6.24103981813 566.287423077 1.28492929317 -6.24203981813 825.742466187 1.28492929317 -6.24303981813 987.256189994 1.28492929317 -6.24403981813 720.96083484 1.28492929317 -6.24503981813 531.247318409 1.28492929317 -6.24603981813 571.775737569 1.28492929317 -6.24703981813 459.003857376 1.28492929317 -6.24803981813 273.682330437 1.28492929317 -6.24903981813 325.293392541 1.28492929317 -6.25003981813 454.684537403 1.28492929317 -6.25103981813 512.045738372 1.28492929317 -6.25203981813 332.477194114 1.28492929317 -6.25303981813 289.774726243 1.28492929317 -6.25403981813 201.434447055 1.28492929317 -6.25503981813 179.222333328 1.28492929317 -6.25603981813 224.998000438 1.28492929317 -6.25703981813 272.502266826 1.28492929317 -6.25803981813 359.347828297 1.28492929317 -6.25903981813 453.54215503 1.28492929317 -6.26003981813 538.750010548 1.28492929317 -6.26103981813 585.627147132 1.28492929317 -6.26203981813 610.673856569 1.28492929317 -6.26303981813 637.554774207 1.28492929317 -6.26403981813 780.38105745 1.28492929317 -6.26503981813 635.850757134 1.28492929317 -6.26603981813 666.687903445 1.28492929317 -6.26703981813 686.359986067 1.28492929317 -6.26803981813 759.22004312 1.28492929317 -6.26903981813 726.713020275 1.28492929317 -6.27003981813 780.082890225 1.28492929317 -6.27103981813 749.154524621 1.28492929317 -6.27203981813 756.069553843 1.28492929317 -6.27303981813 810.836367709 1.28492929317 -6.27403981813 794.895804816 1.28492929317 -6.27503981813 806.060856535 1.28492929317 -6.27603981813 763.659024818 1.28492929317 -6.27703981813 662.332257622 1.28492929317 -6.27803981813 665.164661011 1.28492929317 -6.27903981813 547.587078243 1.28492929317 -6.28003981813 327.33033453 1.28492929317 -6.28103981813 492.240060354 1.28492929317 -6.28203981813 428.560177389 1.28492929317 -6.28303981813 400.855509705 1.28492929317 -6.28403981813 470.550258522 1.28492929317 -6.28503981813 589.310724136 1.28492929317 -6.28603981813 689.402367395 1.28492929317 -6.28703981813 766.671311811 1.28492929317 -6.28803981813 846.222111486 1.28492929317 -6.28903981813 911.863620609 1.28492929317 -6.29003981813 950.201379981 1.28492929317 -6.29103981813 989.882191522 1.28492929317 -6.29203981813 1002.61915907 1.28492929317 -6.29303981813 1041.32181226 1.28492929317 -6.29403981813 1012.14282368 1.28492929317 -6.29503981813 986.198146086 1.28492929317 -6.29603981813 959.567479796 1.28492929317 -6.29703981813 965.320127661 1.28492929317 -6.29803981813 929.247201352 1.28492929317 -6.29903981813 903.426535089 1.28492929317 -6.30003981813 858.1132223 1.28492929317 -6.30103981813 845.717306753 1.28492929317 -6.30203981813 864.763446008 1.28492929317 -6.30303981813 816.823382557 1.28492929317 -6.30403981813 802.262791874 1.28492929317 -6.30503981813 770.178929058 1.28492929317 -6.30603981813 786.314024867 1.28492929317 -6.30703981813 806.606442725 1.28492929317 -6.30803981813 829.899238426 1.28492929317 -6.30903981813 870.45459886 1.28492929317 -6.31003981813 874.076972529 1.28492929317 -6.31103981813 876.980006155 1.28492929317 -6.31203981813 877.038920895 1.28492929317 -6.31303981813 883.543654076 1.28492929317 -6.31403981813 869.270674246 1.28492929317 -6.31503981813 869.420431313 1.28492929317 -6.31603981813 852.264431692 1.28492929317 -6.31703981813 846.937508859 1.28492929317 -6.31803981813 831.352612533 1.28492929317 -6.31903981813 811.353749749 1.28492929317 -6.32003981813 787.255835121 1.28492929317 -6.32103981813 762.294169151 1.28492929317 -6.32203981813 742.107937054 1.28492929317 -6.32303981813 723.048990118 1.28492929317 -6.32403981813 708.350602464 1.28492929317 -6.32503981813 692.125211879 1.28492929317 -6.32603981813 679.120946824 1.28492929317 -6.32703981813 669.981946642 1.28492929317 -6.32803981813 658.198077353 1.28492929317 -6.32903981813 652.667226792 1.28492929317 -6.33003981813 644.613448773 1.28492929317 -6.33103981813 637.644649559 1.28492929317 -6.33203981813 630.98841998 1.28492929317 -6.33303981813 632.485457108 1.28492929317 -6.33403981813 623.881380329 1.28492929317 -6.33503981813 619.642873928 1.28492929317 -6.33603981813 606.166257546 1.28492929317 -6.33703981813 599.731080579 1.28492929317 -6.33803981813 589.629709231 1.28492929317 -6.33903981813 580.193974766 1.28492929317 -6.34003981813 574.682334952 1.28492929317 -6.34103981813 564.22308834 1.28492929317 -6.34203981813 553.49044313 1.28492929317 -6.34303981813 551.28951846 1.28492929317 -6.34403981813 557.531685783 1.28492929317 -6.34503981813 557.214721852 1.28492929317 -6.34603981813 550.839531282 1.28492929317 -6.34703981813 544.196885086 1.28492929317 -6.34803981813 539.748633502 1.28492929317 -6.34903981813 533.60908725 1.28492929317 -6.35003981813 528.930340434 1.28492929317 -6.35103981813 528.247332351 1.28492929317 -6.35203981813 524.701408786 1.28492929317 -6.35303981813 520.246347698 1.28492929317 -6.35403981813 513.367724085 1.28492929317 -6.35503981813 508.269490095 1.28492929317 -6.35603981813 500.295245343 1.28492929317 -6.35703981813 489.675006306 1.28492929317 -6.35803981813 477.764508299 1.28492929317 -6.35903981813 469.338357389 1.28492929317 -6.36003981813 458.31103342 1.28492929317 -6.36103981813 449.119310951 1.28492929317 -6.36203981813 440.738581977 1.28492929317 -6.36303981813 431.260898935 1.28492929317 -6.36403981813 423.526508094 1.28492929317 -6.36503981813 419.550387895 1.28492929317 -6.36603981813 409.432007616 1.28492929317 -6.36703981813 403.736024978 1.28492929317 -6.36803981813 398.353125812 1.28492929317 -6.36903981813 389.136618555 1.28492929317 -6.37003981813 388.521714556 1.28492929317 -6.37103981813 384.867842548 1.28492929317 -6.37203981813 380.694204111 1.28492929317 -6.37303981813 377.795912645 1.28492929317 -6.37403981813 377.465538354 1.28492929317 -6.37503981813 374.851873289 1.28492929317 -6.37603981813 369.125024281 1.28492929317 -6.37703981813 366.899998202 1.28492929317 -6.37803981813 363.013977603 1.28492929317 -6.37903981813 359.030531066 1.28492929317 -6.38003981813 356.327250979 1.28492929317 -6.38103981813 354.013990052 1.28492929317 -6.38203981813 357.02066403 1.28492929317 -6.38303981813 356.231624217 1.28492929317 -6.38403981813 353.122666422 1.28492929317 -6.38503981813 349.997631044 1.28492929317 -6.38603981813 346.768067919 1.28492929317 -6.38703981813 341.9055272 1.28492929317 -6.38803981813 337.100422474 1.28492929317 -6.38903981813 334.325733275 1.28492929317 -6.39003981813 328.395960541 1.28492929317 -6.39103981813 325.290869836 1.28492929317 -6.39203981813 324.63677954 1.28492929317 -6.39303981813 321.131286468 1.28492929317 -6.39403981813 322.111541798 1.28492929317 -6.39503981813 321.470825358 1.28492929317 -6.39603981813 322.060983703 1.28492929317 -6.39703981813 319.672739475 1.28492929317 -6.39803981813 315.210824793 1.28492929317 -6.39903981813 306.970454214 1.28492929317 -6.40003981813 304.270788268 1.28492929317 -6.40103981813 304.226687255 1.28492929317 -6.40203981813 302.949699264 1.28492929317 -6.40303981813 299.083676767 1.28492929317 -6.40403981813 294.017308478 1.28492929317 -6.40503981813 289.185551858 1.28492929317 -6.40603981813 291.155666457 1.28492929317 -6.40703981813 289.534222285 1.28492929317 -6.40803981813 291.88171203 1.28492929317 -6.40903981813 295.081524656 1.28492929317 -6.41003981813 293.367474062 1.28492929317 -6.41103981813 289.474705127 1.28492929317 -6.41203981813 284.384465648 1.28492929317 -6.41303981813 279.140576389 1.28492929317 -6.41403981813 275.395114376 1.28492929317 -6.41503981813 267.167178174 1.28492929317 -6.41603981813 263.1051276 1.28492929317 -6.41703981813 264.20996887 1.28492929317 -6.41803981813 267.438169327 1.28492929317 -6.41903981813 267.772192746 1.28492929317 -6.42003981813 268.154186232 1.28492929317 -6.42103981813 268.55965331 1.28492929317 -6.42203981813 270.770974109 1.28492929317 -6.42303981813 274.042427139 1.28492929317 -6.42403981813 296.592575145 1.28492929317 -6.42503981813 287.199099284 1.28492929317 -6.42603981813 283.978218672 1.28492929317 -6.42703981813 282.773056087 1.28492929317 -6.42803981813 281.562450499 1.28492929317 -6.42903981813 282.106021153 1.28492929317 -6.43003981813 289.58469673 1.28492929317 -6.43103981813 291.884678014 1.28492929317 -6.43203981813 297.841929218 1.28492929317 -6.43303981813 290.354388214 1.28492929317 -6.43403981813 289.430465298 1.28492929317 -6.43503981813 288.168904058 1.28492929317 -6.43603981813 290.066820916 1.28492929317 -6.43703981813 294.609111439 1.28492929317 -6.43803981813 286.36591809 1.28492929317 -6.43903981813 282.891164668 1.28492929317 -6.44003981813 278.432720233 1.28492929317 -6.44103981813 277.238393324 1.28492929317 -6.44203981813 273.563546787 1.28492929317 -6.44303981813 268.851398158 1.28492929317 -6.44403981813 271.44150418 1.28492929317 -6.44503981813 279.275310647 1.28492929317 -6.44603981813 279.878489528 1.28492929317 -6.44703981813 282.115137623 1.28492929317 -6.44803981813 283.891939797 1.28492929317 -6.44903981813 287.008423327 1.28492929317 -6.45003981813 303.169919591 1.28492929317 -6.45103981813 313.690800528 1.28492929317 -6.45203981813 306.999918482 1.28492929317 -6.45303981813 306.967203084 1.28492929317 -6.45403981813 318.209173137 1.28492929317 -6.45503981813 318.775273877 1.28492929317 -6.45603981813 315.95647174 1.28492929317 -6.45703981813 318.989781312 1.28492929317 -6.45803981813 329.842304362 1.28492929317 -6.45903981813 327.345048748 1.28492929317 -6.46003981813 334.522102893 1.28492929317 -6.46103981813 326.059118596 1.28492929317 -6.46203981813 323.479302253 1.28492929317 -6.46303981813 323.941103608 1.28492929317 -6.46403981813 323.535640407 1.28492929317 -6.46503981813 328.551557282 1.28492929317 -6.46603981813 342.123048716 1.28492929317 -6.46703981813 337.386765481 1.28492929317 -6.46803981813 333.413985873 1.28492929317 -6.46903981813 328.739302516 1.28492929317 -6.47003981813 327.662255242 1.28492929317 -6.47103981813 334.130051814 1.28492929317 -6.47203981813 336.884013479 1.28492929317 -6.47303981813 345.077468257 1.28492929317 -6.47403981813 346.105480274 1.28492929317 -6.47503981813 347.140866326 1.28492929317 -6.47603981813 364.316614557 1.28492929317 -6.47703981813 350.369137792 1.28492929317 -6.47803981813 345.102265482 1.28492929317 -6.47903981813 348.499781423 1.28492929317 -6.48003981813 359.810280225 1.28492929317 -6.48103981813 357.618042896 1.28492929317 -6.48203981813 355.696699334 1.28492929317 -6.48303981813 359.129484977 1.28492929317 -6.48403981813 360.607449893 1.28492929317 -6.48503981813 363.582208919 1.28492929317 -6.48603981813 357.507655801 1.28492929317 -6.48703981813 358.382810867 1.28492929317 -6.48803981813 379.821509885 1.28492929317 -6.48903981813 372.449353637 1.28492929317 -6.49003981813 369.523270514 1.28492929317 -6.49103981813 373.668691862 1.28492929317 -6.49203981813 374.869629859 1.28492929317 -6.49303981813 372.504492424 1.28492929317 -6.49403981813 376.71572019 1.28492929317 -6.49503981813 384.361104953 1.28492929317 -6.49603981813 407.613751363 1.28492929317 -6.49703981813 419.994706028 1.28492929317 -6.49803981813 415.148202129 1.28492929317 -6.49903981813 410.492715697 1.28492929317 -6.50003981813 419.827894611 1.28492929317 -6.50103981813 425.888426577 1.28492929317 -6.50203981813 424.162992126 1.28492929317 -6.50303981813 422.834672009 1.28492929317 -6.50403981813 456.931668816 1.28492929317 -6.50503981813 459.227431617 1.28492929317 -6.50603981813 471.185464648 1.28492929317 -6.50703981813 476.471003306 1.28492929317 -6.50803981813 467.646004695 1.28492929317 -6.50903981813 473.717572343 1.28492929317 -6.51003981813 482.026532283 1.28492929317 -6.51103981813 483.101815127 1.28492929317 -6.51203981813 480.162705074 1.28492929317 -6.51303981813 575.610450598 1.28492929317 -6.51403981813 607.172765556 1.28492929317 -6.51503981813 569.117956864 1.28492929317 -6.51603981813 564.667932378 1.28492929317 -6.51703981813 598.494015474 1.28492929317 -6.51803981813 552.654120765 1.28492929317 -6.51903981813 574.269195852 1.28492929317 -6.52003981813 544.540516561 1.28492929317 -6.52103981813 557.840737717 1.28492929317 -6.52203981813 549.300953007 1.28492929317 -6.52303981813 550.502493961 1.28492929317 -6.52403981813 569.417274583 1.28492929317 -6.52503981813 558.416013723 1.28492929317 -6.52603981813 555.718655039 1.28492929317 -6.52703981813 539.730380236 1.28492929317 -6.52803981813 544.107441005 1.28492929317 -6.52903981813 565.88372714 1.28492929317 -6.53003981813 585.257812469 1.28492929317 -6.53103981813 598.516387403 1.28492929317 -6.53203981813 586.436933056 1.28492929317 -6.53303981813 584.874950445 1.28492929317 -6.53403981813 590.86397328 1.28492929317 -6.53503981813 587.05626228 1.28492929317 -6.53603981813 600.869006841 1.28492929317 -6.53703981813 576.875023374 1.28492929317 -6.53803981813 580.465170501 1.28492929317 -6.53903981813 543.884837306 1.28492929317 -6.54003981813 531.173090426 1.28492929317 -6.54103981813 529.815398573 1.28492929317 -6.54203981813 536.052611587 1.28492929317 -6.54303981813 582.870051163 1.28492929317 -6.54403981813 590.491271343 1.28492929317 -6.54503981813 598.827475077 1.28492929317 -6.54603981813 619.005431235 1.28492929317 -6.54703981813 638.265767862 1.28492929317 -6.54803981813 653.503771733 1.28492929317 -6.54903981813 667.309770608 1.28492929317 -6.55003981813 668.779625021 1.28492929317 -6.55103981813 685.356013099 1.28492929317 -6.55203981813 700.890846268 1.28492929317 -6.55303981813 704.251392056 1.28492929317 -6.55403981813 710.271527431 1.28492929317 -6.55503981813 709.06080562 1.28492929317 -6.55603981813 693.839192298 1.28492929317 -6.55703981813 693.719233536 1.28492929317 -6.55803981813 695.500500318 1.28492929317 -6.55903981813 711.837934149 1.28492929317 -6.56003981813 710.994207939 1.28492929317 -6.56103981813 702.47313723 1.28492929317 -6.56203981813 694.88039124 1.28492929317 -6.56303981813 694.930942259 1.28492929317 -6.56403981813 720.260917496 1.28492929317 -6.56503981813 706.770870143 1.28492929317 -6.56603981813 793.426411501 1.28492929317 -6.56703981813 768.243960258 1.28492929317 -6.56803981813 791.360461236 1.28492929317 -6.56903981813 749.316236517 1.28492929317 -6.57003981813 724.234096571 1.28492929317 -6.57103981813 733.882157248 1.28492929317 -6.57203981813 683.89449667 1.28492929317 -6.57303981813 709.413789605 1.28492929317 -6.57403981813 687.519285498 1.28492929317 -6.57503981813 666.446389567 1.28492929317 -6.57603981813 645.353167015 1.28492929317 -6.57703981813 653.864247181 1.28492929317 -6.57803981813 659.360614618 1.28492929317 -6.57903981813 642.740007276 1.28492929317 -6.58003981813 619.569547761 1.28492929317 -6.58103981813 624.313521531 1.28492929317 -6.58203981813 652.221259407 1.28492929317 -6.58303981813 670.102685564 1.28492929317 -6.58403981813 690.899382181 1.28492929317 -6.58503981813 676.204592274 1.28492929317 -6.58603981813 705.29434808 1.28492929317 -6.58703981813 702.918907916 1.28492929317 -6.58803981813 762.112523529 1.28492929317 -6.58903981813 776.791790675 1.28492929317 -6.59003981813 784.040342707 1.28492929317 -6.59103981813 993.211553018 1.28492929317 -6.59203981813 1010.00219714 1.28492929317 -6.59303981813 986.684673994 1.28492929317 -6.59403981813 993.39124545 1.28492929317 -6.59503981813 995.890552476 1.28492929317 -6.59603981813 1126.51999079 1.28492929317 -6.59703981813 1096.60849593 1.28492929317 -6.59803981813 1066.26367741 1.28492929317 -6.59903981813 984.706725048 1.28492929317 -6.60003981813 971.317742926 1.28492929317 -6.60103981813 894.857997558 1.28492929317 -6.60203981813 890.805098257 1.28492929317 -6.60303981813 977.037790589 1.28492929317 -6.60403981813 856.649647208 1.28492929317 -6.60503981813 787.589583014 1.28492929317 -6.60603981813 727.822308596 1.28492929317 -6.60703981813 680.510699094 1.28492929317 -6.60803981813 642.086695121 1.28492929317 -6.60903981813 570.812277523 1.28492929317 -6.61003981813 500.395464227 1.28492929317 -6.61103981813 462.424506147 1.28492929317 -6.61203981813 443.808549831 1.28492929317 -6.61303981813 389.756133102 1.28492929317 -6.61403981813 455.263852212 1.28492929317 -6.61503981813 444.822906575 1.28492929317 -6.61603981813 445.824004423 1.28492929317 -6.61703981813 461.068295256 1.28492929317 -6.61803981813 504.892154722 1.28492929317 -6.61903981813 518.898166732 1.28492929317 -6.62003981813 548.669193659 1.28492929317 -6.62103981813 545.992810274 1.28492929317 -6.62203981813 584.000855332 1.28492929317 -6.62303981813 566.393360787 1.28492929317 -6.62403981813 582.999369323 1.28492929317 -6.62503981813 606.692838034 1.28492929317 -6.62603981813 578.734254574 1.28492929317 -6.62703981813 573.310461545 1.28492929317 -6.62803981813 564.202700629 1.28492929317 -6.62903981813 535.936722357 1.28492929317 -6.63003981813 538.677400472 1.28492929317 -6.63103981813 533.990427089 1.28492929317 -6.63203981813 492.970184785 1.28492929317 -6.63303981813 497.523981404 1.28492929317 -6.63403981813 446.380316412 1.28492929317 -6.63503981813 463.673910043 1.28492929317 -6.63603981813 406.001142884 1.28492929317 -6.63703981813 366.806814949 1.28492929317 -6.63803981813 347.05261928 1.28492929317 -6.63903981813 374.005094839 1.28492929317 -6.64003981813 364.765041404 1.28492929317 -6.64103981813 344.681145546 1.28492929317 -6.64203981813 328.529870857 1.28492929317 -6.64303981813 316.25372469 1.28492929317 -6.64403981813 321.032574683 1.28492929317 -6.64503981813 282.920496593 1.28492929317 -6.64603981813 299.90298645 1.28492929317 -6.64703981813 328.381137088 1.28492929317 -6.64803981813 375.029245401 1.28492929317 -6.64903981813 393.170180125 1.28492929317 -6.65003981813 436.599938174 1.28492929317 -6.65103981813 324.389029697 1.28492929317 -6.65203981813 328.285499308 1.28492929317 -6.65303981813 284.087928409 1.28492929317 -6.65403981813 224.450422619 1.28492929317 -6.65503981813 295.105379805 1.28492929317 -6.65603981813 317.581900569 1.28492929317 -6.65703981813 260.753758371 1.28492929317 -6.65803981813 304.94451551 1.28492929317 -6.65903981813 283.160091347 1.28492929317 -6.66003981813 281.720633819 1.28492929317 -6.66103981813 263.483943436 1.28492929317 -6.66203981813 285.718582571 1.28492929317 -6.66303981813 261.198219439 1.28492929317 -6.66403981813 253.258441662 1.28492929317 -6.66503981813 283.662344097 1.28492929317 -6.66603981813 260.948055243 1.28492929317 -6.66703981813 257.366766485 1.28492929317 -6.66803981813 243.78656943 1.28492929317 -6.66903981813 253.838401999 1.28492929317 -6.67003981813 259.429523962 1.28492929317 -6.67103981813 251.969412884 1.28492929317 -6.67203981813 217.907942891 1.28492929317 -6.67303981813 197.530748199 1.28492929317 -6.67403981813 191.483331171 1.28492929317 -6.67503981813 160.712739559 1.28492929317 -6.67603981813 174.16933711 1.28492929317 -6.67703981813 159.497895043 1.28492929317 -6.67803981813 149.994212088 1.28492929317 -6.67903981813 163.146227159 1.28492929317 -6.68003981813 133.351677129 1.28492929317 -6.68103981813 160.322369986 1.28492929317 -6.68203981813 142.764522165 1.28492929317 -6.68303981813 143.337409314 1.28492929317 -6.68403981813 139.492366181 1.28492929317 -6.68503981813 129.29651911 1.28492929317 -6.68603981813 126.763663485 1.28492929317 -6.68703981813 125.888078338 1.28492929317 -6.68803981813 111.028268807 1.28492929317 -6.68903981813 108.435270213 1.28492929317 -6.69003981813 90.605813409 1.28492929317 -6.69103981813 107.115199171 1.28492929317 -6.69203981813 64.4960511557 1.28492929317 -6.69303981813 100.001292154 1.28492929317 -6.69403981813 100.759489804 1.28492929317 -6.69503981813 105.665936879 1.28492929317 -6.69603981813 105.270127541 1.28492929317 -6.69703981813 100.519486926 1.28492929317 -6.69803981813 96.6254777821 1.28492929317 -6.69903981813 91.4228296431 1.28492929317 -6.70003981813 86.8108701722 1.28492929317 -6.70103981813 72.7253310937 1.28492929317 -6.70203981813 79.9265297657 1.28492929317 -6.70303981813 75.2498452712 1.28492929317 -6.70403981813 91.0102713148 1.28492929317 -6.70503981813 89.8155621695 1.28492929317 -6.70603981813 75.1135647824 1.28492929317 -6.70703981813 91.5225050355 1.28492929317 -6.70803981813 120.958708158 1.28492929317 -6.70903981813 123.255219177 1.28492929317 -6.71003981813 99.6809741858 1.28492929317 -6.71103981813 75.8106243051 1.28492929317 -6.71203981813 100.083480495 1.28492929317 -6.71303981813 84.0752076889 1.28492929317 -6.71403981813 71.345741064 1.28492929317 -6.71503981813 104.323477216 1.28492929317 -6.71603981813 86.0024594618 1.28492929317 -6.71703981813 102.924591493 1.28492929317 -6.71803981813 106.390300127 1.28492929317 -6.71903981813 77.361472444 1.28492929317 -6.72003981813 62.0205291745 1.28492929317 -6.72103981813 52.9400023717 1.28492929317 -6.72203981813 69.9372190707 1.28492929317 -6.72303981813 59.470544576 1.28492929317 -6.72403981813 116.583731506 1.28492929317 -6.72503981813 105.074137036 1.28492929317 -6.72603981813 102.524729292 1.28492929317 -6.72703981813 154.663033755 1.28492929317 -6.72803981813 155.69621303 1.28492929317 -6.72903981813 141.428520761 1.28492929317 -6.73003981813 133.183329712 1.28492929317 -6.73103981813 109.190583402 1.28492929317 -6.73203981813 84.7913585805 1.28492929317 -6.73303981813 55.5073692996 1.28492929317 -6.73403981813 71.0225808117 1.28492929317 -6.73503981813 63.9936401084 1.28492929317 -6.73603981813 49.2457554869 1.28492929317 -6.73703981813 6.88206891281 1.28492929317 -6.73803981813 -9.35643228114 1.28492929317 -6.73903981813 5.64089045719 1.28492929317 -6.74003981813 14.4369227034 1.28492929317 -6.74103981813 -51.1036970463 1.28492929317 -6.74203981813 15.2863734046 1.28492929317 -6.74303981813 35.466488345 1.28492929317 -6.74403981813 37.1508672691 1.28492929317 -6.74503981813 26.6087540731 1.28492929317 -6.74603981813 58.8661246846 1.28492929317 -6.74703981813 11.5694720551 1.28492929317 -6.74803981813 98.7965874183 1.28492929317 -6.74903981813 207.32497823 1.28492929317 -6.75003981813 231.381962329 1.28492929317 -6.75103981813 227.263295519 1.28492929317 -6.75203981813 213.818215228 1.28492929317 -6.75303981813 197.11185251 1.28492929317 -6.75403981813 164.401085092 1.28492929317 -6.75503981813 136.720751119 1.28492929317 -6.75603981813 128.027459259 1.28492929317 -6.75703981813 108.555487836 1.28492929317 -6.75803981813 93.9777551858 1.28492929317 -6.75903981813 75.1408860182 1.28492929317 -6.76003981813 123.314472694 1.28492929317 -6.76103981813 95.7975999714 1.28492929317 -6.76203981813 55.7112373144 1.28492929317 -6.76303981813 41.5014007018 1.28492929317 -6.76403981813 20.270939916 1.28492929317 -6.76503981813 10.5844680728 1.28492929317 -6.76603981813 21.8615653061 1.28492929317 -6.76703981813 26.8522642357 1.28492929317 -6.76803981813 27.3364024498 1.28492929317 -6.76903981813 30.2500306386 1.28492929317 -6.77003981813 25.0518582527 1.28492929317 -6.77103981813 40.0359847007 1.28492929317 -6.77203981813 77.8347343115 1.28492929317 -6.77303981813 110.557546546 1.28492929317 -6.77403981813 108.758583162 1.28492929317 -6.77503981813 103.071334489 1.28492929317 -6.77603981813 86.4866582518 1.28492929317 -6.77703981813 64.4376214254 1.28492929317 -6.77803981813 49.019406675 1.28492929317 -6.77903981813 34.8363534171 1.28492929317 -6.78003981813 24.6015994455 1.28492929317 -6.78103981813 17.3849741856 1.28492929317 -6.78203981813 25.9503696283 1.28492929317 -6.78303981813 31.148818567 1.28492929317 -6.78403981813 34.6573690919 1.28492929317 -6.78503981813 37.390424118 1.28492929317 -6.78603981813 55.2777458005 1.28492929317 -6.78703981813 48.4125541151 1.28492929317 -6.78803981813 39.1739114229 1.28492929317 -6.78903981813 31.1048065915 1.28492929317 -6.79003981813 28.2537280643 1.28492929317 -6.79103981813 21.2539743172 1.28492929317 -6.79203981813 21.8980942317 1.28492929317 -6.79303981813 28.8454528007 1.28492929317 -6.79403981813 40.7366584136 1.28492929317 -6.79503981813 39.6592280975 1.28492929317 -6.79603981813 40.5410674591 1.28492929317 -6.79703981813 55.4212056391 1.28492929317 -6.79803981813 43.9792620618 1.28492929317 -6.79903981813 28.7374457201 1.28492929317 -6.80003981813 28.4402038441 1.28492929317 -6.80103981813 15.6608115093 1.28492929317 -6.80203981813 12.5170729829 1.28492929317 -6.80303981813 9.98022817899 1.28492929317 -6.80403981813 20.3254420919 1.28492929317 -6.80503981813 24.366560543 1.28492929317 -6.80603981813 29.5060780961 1.28492929317 -6.80703981813 31.043031782 1.28492929317 -6.80803981813 26.1699203523 1.28492929317 -6.80903981813 20.4056735987 1.28492929317 -6.81003981813 16.8859134055 1.28492929317 -6.81103981813 15.4618463533 1.28492929317 -6.81203981813 28.8516979158 1.28492929317 -6.81303981813 13.1465251044 1.28492929317 -6.81403981813 -1.96970856107 1.28492929317 -6.81503981813 14.7421095044 1.28492929317 -6.81603981813 -4.81138500256 1.28492929317 -6.81703981813 -10.127711871 1.28492929317 -6.81803981813 -7.01528193622 1.28492929317 -6.81903981813 2.93666240041 1.28492929317 -6.82003981813 12.9265200218 1.28492929317 -6.82103981813 26.9322834693 1.28492929317 -6.82203981813 24.7121009806 1.28492929317 -6.82303981813 20.7639243759 1.28492929317 -6.82403981813 15.2657137635 1.28492929317 -6.82503981813 11.0235255245 1.28492929317 -6.82603981813 9.22188754336 1.28492929317 -6.82703981813 5.9867158835 1.28492929317 -6.82803981813 1.17291192044 1.28492929317 -6.82903981813 -4.91073294397 1.28492929317 -6.83003981813 -4.65271563935 1.28492929317 -6.83103981813 -4.90421903819 1.28492929317 -6.83203981813 -9.98324199261 1.28492929317 -6.83303981813 -10.6415771363 1.28492929317 -6.83403981813 -6.31564450038 1.28492929317 -6.83503981813 0.077722095819 1.28492929317 -6.83603981813 -3.62158852835 1.28492929317 -6.83703981813 -11.1876424051 1.28492929317 -6.83803981813 -20.9837562074 1.28492929317 -6.83903981813 -18.5343018554 1.28492929317 -6.84003981813 -20.9726702164 1.28492929317 -6.84103981813 -18.055373975 1.28492929317 -6.84203981813 -19.7256210635 1.28492929317 -6.84303981813 -17.7155612051 1.28492929317 -6.84403981813 -17.5267141416 1.28492929317 -6.84503981813 -9.83501068945 1.28492929317 -6.84603981813 -9.2608669615 1.28492929317 -6.84703981813 -11.7238155771 1.28492929317 -6.84803981813 -4.37401542824 1.28492929317 -6.84903981813 3.6997131077 1.28492929317 -6.85003981813 16.6340757686 1.28492929317 -6.85103981813 11.296083668 1.28492929317 -6.85203981813 3.1797775497 1.28492929317 -6.85303981813 -4.57560895907 1.28492929317 -6.85403981813 -13.0497596789 1.28492929317 -6.85503981813 -17.6956280781 1.28492929317 -6.85603981813 -15.7143437959 1.28492929317 -6.85703981813 -10.5318184614 1.28492929317 -6.85803981813 -6.60897042748 1.28492929317 -6.85903981813 -3.91930175936 1.28492929317 -6.86003981813 0.0827031626479 1.28492929317 -6.86103981813 3.75344037621 1.28492929317 -6.86203981813 6.87817431384 1.28492929317 -6.86303981813 26.2340811523 1.28492929317 -6.86403981813 18.6012937284 1.28492929317 -6.86503981813 18.3916370318 1.28492929317 -6.86603981813 27.0734145312 1.28492929317 -6.86703981813 26.8035317461 1.28492929317 -6.86803981813 21.1654316124 1.28492929317 -6.86903981813 26.9382796553 1.28492929317 -6.87003981813 34.1753000283 1.28492929317 -6.87103981813 39.4394296703 1.28492929317 -6.87203981813 38.5674031145 1.28492929317 -6.87303981813 33.6579249301 1.28492929317 -6.87403981813 34.1513127406 1.28492929317 -6.87503981813 32.6510079548 1.28492929317 -6.87603981813 27.7848506549 1.28492929317 -6.87703981813 23.315121265 1.28492929317 -6.87803981813 26.4925298394 1.28492929317 -6.87903981813 16.3167799818 1.28492929317 -6.88003981813 9.97569393369 1.28492929317 -6.88103981813 6.72995305468 1.28492929317 -6.88203981813 9.70815133944 1.28492929317 -6.88303981813 15.2257228347 1.28492929317 -6.88403981813 21.4719144218 1.28492929317 -6.88503981813 27.6638114503 1.28492929317 -6.88603981813 40.293757254 1.28492929317 -6.88703981813 39.6166474948 1.28492929317 -6.88803981813 34.2378159189 1.28492929317 -6.88903981813 30.2642325774 1.28492929317 -6.89003981813 21.421246604 1.28492929317 -6.89103981813 22.2313587173 1.28492929317 -6.89203981813 14.7934434756 1.28492929317 -6.89303981813 21.701730602 1.28492929317 -6.89403981813 20.0464010712 1.28492929317 -6.89503981813 26.8277560779 1.28492929317 -6.89603981813 49.2945441033 1.28492929317 -6.89703981813 28.2581005069 1.28492929317 -6.89803981813 19.426223677 1.28492929317 -6.89903981813 27.4234619219 1.28492929317 -6.90003981813 71.2909324468 1.28492929317 -6.90103981813 64.8529515151 1.28492929317 -6.90203981813 50.6072448969 1.28492929317 -6.90303981813 14.8643280376 1.28492929317 -6.90403981813 11.1417311659 1.28492929317 -6.90503981813 14.6407669904 1.28492929317 -6.90603981813 35.9006749297 1.28492929317 -6.90703981813 38.6320626093 1.28492929317 -6.90803981813 33.6096942508 1.28492929317 -6.90903981813 30.7642804932 1.28492929317 -6.91003981813 31.091639967 1.28492929317 -6.91103981813 32.6969030712 1.28492929317 -6.91203981813 34.8065480444 1.28492929317 -6.91303981813 39.267485665 1.28492929317 -6.91403981813 38.0814461377 1.28492929317 -6.91503981813 48.6050572088 1.28492929317 -6.91603981813 23.2849089976 1.28492929317 -6.91703981813 40.093252938 1.28492929317 -6.91803981813 22.873254236 1.28492929317 -6.91903981813 39.8840430245 1.28492929317 -6.92003981813 55.2077255194 1.28492929317 -6.92103981813 23.6670152422 1.28492929317 -6.92203981813 43.0229022143 1.28492929317 -6.92303981813 53.9345434197 1.28492929317 -6.92403981813 14.9628450641 1.28492929317 -6.92503981813 24.2171338959 1.28492929317 -6.92603981813 26.1846176304 1.28492929317 -6.92703981813 25.7719774241 1.28492929317 -6.92803981813 50.4556333156 1.28492929317 -6.92903981813 17.7964918782 1.28492929317 -6.93003981813 15.5542978084 1.28492929317 -6.93103981813 19.2446219002 1.28492929317 -6.93203981813 63.9477357646 1.28492929317 -6.93303981813 55.2363689637 1.28492929317 -6.93403981813 35.9220496364 1.28492929317 -6.93503981813 20.9800697206 1.28492929317 -6.93603981813 12.1588647487 1.28492929317 -6.93703981813 9.0936580483 1.28492929317 -6.93803981813 11.0873300572 1.28492929317 -6.93903981813 16.8879957246 1.28492929317 -6.94003981813 22.7376516174 1.28492929317 -6.94103981813 27.5621294525 1.28492929317 -6.94203981813 28.8171952795 1.28492929317 -6.94303981813 29.4959430061 1.28492929317 -6.94403981813 28.4792445643 1.28492929317 -6.94503981813 29.530010889 1.28492929317 -6.94603981813 33.7711204877 1.28492929317 -6.94703981813 33.5511606816 1.28492929317 -6.94803981813 32.3148050975 1.28492929317 -6.94903981813 31.258563052 1.28492929317 -6.95003981813 30.6026902068 1.28492929317 -6.95103981813 31.1238807045 1.28492929317 -6.95203981813 31.2922176152 1.28492929317 -6.95303981813 31.4547280673 1.28492929317 -6.95403981813 30.8694804193 1.28492929317 -6.95503981813 31.0979315673 1.28492929317 -6.95603981813 28.3689609827 1.28492929317 -6.95703981813 24.7721902902 1.28492929317 -6.95803981813 23.1592204315 1.28492929317 -6.95903981813 23.4329180922 1.28492929317 -6.96003981813 25.6241686995 1.28492929317 -6.96103981813 23.9022606405 1.28492929317 -6.96203981813 19.1924631534 1.28492929317 -6.96303981813 15.8507454371 1.28492929317 -6.96403981813 13.4257904946 1.28492929317 -6.96503981813 12.4782640118 1.28492929317 -6.96603981813 18.4012249651 1.28492929317 -6.96703981813 17.6304756916 1.28492929317 -6.96803981813 12.4858382335 1.28492929317 -6.96903981813 8.70087990975 1.28492929317 -6.97003981813 5.63236306938 1.28492929317 -6.97103981813 2.1185382743 1.28492929317 -6.97203981813 -1.77968833281 1.28492929317 -6.97303981813 -0.598313453246 1.28492929317 -6.97403981813 -4.08432964613 1.28492929317 -6.97503981813 -6.07381870186 1.28492929317 -6.97603981813 -7.08679481012 1.28492929317 -6.97703981813 -6.38810266857 1.28492929317 -6.97803981813 -5.68589930127 1.28492929317 -6.97903981813 -4.88963795091 1.28492929317 -6.98003981813 -3.01021354551 1.28492929317 -6.98103981813 -5.38887571966 1.28492929317 -6.98203981813 -8.99552828153 1.28492929317 -6.98303981813 -9.90162446052 1.28492929317 -6.98403981813 -14.9427880655 1.28492929317 -6.98503981813 -19.9136273962 1.28492929317 -6.98603981813 -24.2391368479 1.28492929317 -6.98703981813 -27.2581668821 1.28492929317 -6.98803981813 -24.3078210099 1.28492929317 -6.98903981813 -24.6406026091 1.28492929317 -6.99003981813 -32.3343002252 1.28492929317 -6.99103981813 -45.0854592395 1.28492929317 -6.99203981813 -54.2082558001 1.28492929317 -6.99303981813 -57.4838737975 1.28492929317 -6.99403981813 -57.6075376234 1.28492929317 -6.99503981813 -63.092367497 1.28492929317 -6.99603981813 -48.5224511301 1.28492929317 -6.99703981813 -27.0795632926 1.28492929317 -6.99803981813 -28.9811489411 1.28492929317 -6.99903981813 -42.8400942016 1.28492929317 -7.00003981813 -42.8400942016 1.28492929317 -7.00103981813 -42.8400942016 1.28492929317 -7.00203981813 -42.8400942016 1.28492929317 -7.00303981813 -42.8400942016 1.28492929317 -7.00403981813 -42.8400942016 1.28492929317 -7.00503981813 -42.8400942016 1.28492929317 -7.00603981813 -42.8400942016 1.28492929317 -7.00703981813 -42.8400942016 1.28492929317 -7.00803981813 -42.8400942016 1.28492929317 -7.00903981813 -42.8400942016 1.28492929317 -7.01003981813 -42.8400942016 1.28492929317 -7.01103981813 -42.8400942016 1.28492929317 -7.01203981813 -42.8400942016 1.28492929317 -7.01303981813 -42.8400942016 1.28492929317 -7.01403981813 -42.8400942016 1.28492929317 -7.01503981813 -42.8400942016 1.28492929317 -7.01603981813 -42.8400942016 1.28492929317 -7.01703981813 -42.8400942016 1.28492929317 -7.01803981813 -42.8400942016 1.28492929317 -7.01903981813 -42.8400942016 1.28492929317 -7.02003981813 -42.8400942016 1.28492929317 -7.02103981813 -42.8400942016 1.28492929317 -7.02203981813 -42.8400942016 1.28492929317 -7.02303981813 -42.8400942016 1.28492929317 -7.02403981813 -42.8400942016 1.28492929317 -7.02503981813 -42.8400942016 1.28492929317 -7.02603981813 -42.8400942016 1.28492929317 -7.02703981813 -42.8400942016 1.28492929317 -7.02803981813 -42.8400942016 1.28492929317 -7.02903981813 -42.8400942016 1.28492929317 -7.03003981813 -42.8400942016 1.28492929317 -7.03103981813 -42.8400942016 1.28492929317 -7.03203981813 -42.8400942016 1.28492929317 -7.03303981813 -42.8400942016 1.28492929317 -7.03403981813 -42.8400942016 1.28492929317 -7.03503981813 -42.8400942016 1.28492929317 -7.03603981813 -42.8400942016 1.28492929317 -7.03703981813 -42.8400942016 1.28492929317 -7.03803981813 -42.8400942016 1.28492929317 -7.03903981813 -42.8400942016 1.28492929317 -7.04003981813 -42.8400942016 1.28492929317 -7.04103981813 -42.8400942016 1.28492929317 -7.04203981813 -42.8400942016 1.28492929317 -7.04303981813 -42.8400942016 1.28492929317 -7.04403981813 -42.8400942016 1.28492929317 -7.04503981813 -42.8400942016 1.28492929317 -7.04603981813 -42.8400942016 1.28492929317 -7.04703981813 -42.8400942016 1.28492929317 -7.04803981813 -42.8400942016 1.28492929317 -7.04903981813 -42.8400942016 1.28492929317 -7.05003981813 -42.8400942016 1.28492929317 -7.05103981813 -42.8400942016 1.28492929317 -7.05203981813 -42.8400942016 1.28492929317 -7.05303981813 -42.8400942016 1.28492929317 -7.05403981813 -42.8400942016 1.28492929317 -7.05503981813 -42.8400942016 1.28492929317 -7.05603981813 -42.8400942016 1.28492929317 -7.05703981813 -42.8400942016 1.28492929317 -7.05803981813 -42.8400942016 1.28492929317 -7.05903981813 -42.8400942016 1.28492929317 -7.06003981813 -42.8400942016 1.28492929317 -7.06103981813 -42.8400942016 1.28492929317 -7.06203981813 -42.8400942016 1.28492929317 -7.06303981813 -42.8400942016 1.28492929317 -7.06403981813 -42.8400942016 1.28492929317 -7.06503981813 -42.8400942016 1.28492929317 -7.06603981813 -42.8400942016 1.28492929317 -7.06703981813 -42.8400942016 1.28492929317 -7.06803981813 -42.8400942016 1.28492929317 -7.06903981813 -42.8400942016 1.28492929317 -7.07003981813 -42.8400942016 1.28492929317 -7.07103981813 -42.8400942016 1.28492929317 -7.07203981813 -42.8400942016 1.28492929317 -7.07303981813 -42.8400942016 1.28492929317 -7.07403981813 -42.8400942016 1.28492929317 -7.07503981813 -42.8400942016 1.28492929317 -7.07603981813 -42.8400942016 1.28492929317 -7.07703981813 -42.8400942016 1.28492929317 -7.07803981813 -42.8400942016 1.28492929317 -7.07903981813 -42.8400942016 1.28492929317 -7.08003981813 -42.8400942016 1.28492929317 -7.08103981813 -42.8400942016 1.28492929317 -7.08203981813 -42.8400942016 1.28492929317 -7.08303981813 -42.8400942016 1.28492929317 -7.08403981813 -42.8400942016 1.28492929317 -7.08503981813 -42.8400942016 1.28492929317 -7.08603981813 -42.8400942016 1.28492929317 -7.08703981813 -42.8400942016 1.28492929317 -7.08803981813 -42.8400942016 1.28492929317 -7.08903981813 -42.8400942016 1.28492929317 -7.09003981813 -42.8400942016 1.28492929317 -7.09103981813 -42.8400942016 1.28492929317 -7.09203981813 -42.8400942016 1.28492929317 -7.09303981813 -42.8400942016 1.28492929317 -7.09403981813 -42.8400942016 1.28492929317 -7.09503981813 -42.8400942016 1.28492929317 -7.09603981813 -42.8400942016 1.28492929317 -7.09703981813 -42.8400942016 1.28492929317 -7.09803981813 -42.8400942016 1.28492929317 -7.09903981813 -42.8400942016 1.28492929317 -7.10003981813 -42.8400942016 1.28492929317 -7.10103981813 -42.8400942016 1.28492929317 -7.10203981813 -42.8400942016 1.28492929317 -7.10303981813 -42.8400942016 1.28492929317 -7.10403981813 -42.8400942016 1.28492929317 -7.10503981813 -42.8400942016 1.28492929317 -7.10603981813 -42.8400942016 1.28492929317 -7.10703981813 -42.8400942016 1.28492929317 -7.10803981813 -42.8400942016 1.28492929317 -7.10903981813 -42.8400942016 1.28492929317 -7.11003981813 -42.8400942016 1.28492929317 -7.11103981813 -42.8400942016 1.28492929317 -7.11203981813 -42.8400942016 1.28492929317 -7.11303981813 -42.8400942016 1.28492929317 -7.11403981813 -42.8400942016 1.28492929317 -7.11503981813 -42.8400942016 1.28492929317 -7.11603981813 -42.8400942016 1.28492929317 -7.11703981813 -42.8400942016 1.28492929317 -7.11803981813 -42.8400942016 1.28492929317 -7.11903981813 -42.8400942016 1.28492929317 -7.12003981813 -42.8400942016 1.28492929317 -7.12103981813 -42.8400942016 1.28492929317 -7.12203981813 -42.8400942016 1.28492929317 -7.12303981813 -42.8400942016 1.28492929317 -7.12403981813 -42.8400942016 1.28492929317 -7.12503981813 -42.8400942016 1.28492929317 -7.12603981813 -42.8400942016 1.28492929317 -7.12703981813 -42.8400942016 1.28492929317 -7.12803981813 -42.8400942016 1.28492929317 -7.12903981813 -42.8400942016 1.28492929317 -7.13003981813 -42.8400942016 1.28492929317 -7.13103981813 -42.8400942016 1.28492929317 -7.13203981813 -42.8400942016 1.28492929317 -7.13303981813 -42.8400942016 1.28492929317 -7.13403981813 -42.8400942016 1.28492929317 -7.13503981813 -42.8400942016 1.28492929317 -7.13603981813 -42.8400942016 1.28492929317 -7.13703981813 -42.8400942016 1.28492929317 -7.13803981813 -42.8400942016 1.28492929317 -7.13903981813 -42.8400942016 1.28492929317 -7.14003981813 -42.8400942016 1.28492929317 -7.14103981813 -42.8400942016 1.28492929317 -7.14203981813 -42.8400942016 1.28492929317 -7.14303981813 -42.8400942016 1.28492929317 -7.14403981813 -42.8400942016 1.28492929317 -7.14503981813 -42.8400942016 1.28492929317 -7.14603981813 -42.8400942016 1.28492929317 -7.14703981813 -42.8400942016 1.28492929317 -7.14803981813 -42.8400942016 1.28492929317 -7.14903981813 -42.8400942016 1.28492929317 -7.15003981813 -42.8400942016 1.28492929317 -7.15103981813 -42.8400942016 1.28492929317 -7.15203981813 -42.8400942016 1.28492929317 -7.15303981813 -42.8400942016 1.28492929317 -7.15403981813 -42.8400942016 1.28492929317 -7.15503981813 -42.8400942016 1.28492929317 -7.15603981813 -42.8400942016 1.28492929317 -7.15703981813 -42.8400942016 1.28492929317 -7.15803981813 -42.8400942016 1.28492929317 -7.15903981813 -42.8400942016 1.28492929317 -7.16003981813 -42.8400942016 1.28492929317 -7.16103981813 -42.8400942016 1.28492929317 -7.16203981813 -42.8400942016 1.28492929317 -7.16303981813 -42.8400942016 1.28492929317 -7.16403981813 -42.8400942016 1.28492929317 -7.16503981813 -42.8400942016 1.28492929317 -7.16603981813 -42.8400942016 1.28492929317 -7.16703981813 -42.8400942016 1.28492929317 -7.16803981813 -42.8400942016 1.28492929317 -7.16903981813 -42.8400942016 1.28492929317 -7.17003981813 -42.8400942016 1.28492929317 -7.17103981813 -42.8400942016 1.28492929317 -7.17203981813 -42.8400942016 1.28492929317 -7.17303981813 -42.8400942016 1.28492929317 -7.17403981813 -42.8400942016 1.28492929317 -7.17503981813 -42.8400942016 1.28492929317 -7.17603981813 -42.8400942016 1.28492929317 -7.17703981813 -42.8400942016 1.28492929317 -7.17803981813 -42.8400942016 1.28492929317 -7.17903981813 -42.8400942016 1.28492929317 -7.18003981813 -42.8400942016 1.28492929317 -7.18103981813 -42.8400942016 1.28492929317 -7.18203981813 -42.8400942016 1.28492929317 -7.18303981813 -42.8400942016 1.28492929317 -7.18403981813 -42.8400942016 1.28492929317 -7.18503981813 -42.8400942016 1.28492929317 -7.18603981813 -42.8400942016 1.28492929317 -7.18703981813 -42.8400942016 1.28492929317 -7.18803981813 -42.8400942016 1.28492929317 -7.18903981813 -42.8400942016 1.28492929317 -7.19003981813 -42.8400942016 1.28492929317 -7.19103981813 -42.8400942016 1.28492929317 -7.19203981813 -42.8400942016 1.28492929317 -7.19303981813 -42.8400942016 1.28492929317 -7.19403981813 -42.8400942016 1.28492929317 -7.19503981813 -42.8400942016 1.28492929317 -7.19603981813 -42.8400942016 1.28492929317 -7.19703981813 -42.8400942016 1.28492929317 -7.19803981813 -42.8400942016 1.28492929317 -7.19903981813 -42.8400942016 1.28492929317 -7.20003981813 -42.8400942016 1.28492929317 -7.20103981813 -42.8400942016 1.28492929317 -7.20203981813 -42.8400942016 1.28492929317 -7.20303981813 -42.8400942016 1.28492929317 -7.20403981813 -42.8400942016 1.28492929317 -7.20503981813 -42.8400942016 1.28492929317 -7.20603981813 -42.8400942016 1.28492929317 -7.20703981813 -42.8400942016 1.28492929317 -7.20803981813 -42.8400942016 1.28492929317 -7.20903981813 -42.8400942016 1.28492929317 -7.21003981813 -42.8400942016 1.28492929317 -7.21103981813 -42.8400942016 1.28492929317 -7.21203981813 -42.8400942016 1.28492929317 -7.21303981813 -42.8400942016 1.28492929317 -7.21403981813 -42.8400942016 1.28492929317 -7.21503981813 -42.8400942016 1.28492929317 -7.21603981813 -42.8400942016 1.28492929317 -7.21703981813 -42.8400942016 1.28492929317 -7.21803981813 -42.8400942016 1.28492929317 -7.21903981813 -42.8400942016 1.28492929317 -7.22003981813 -42.8400942016 1.28492929317 -7.22103981813 -42.8400942016 1.28492929317 -7.22203981813 -42.8400942016 1.28492929317 -7.22303981813 -42.8400942016 1.28492929317 -7.22403981813 -42.8400942016 1.28492929317 -7.22503981813 -42.8400942016 1.28492929317 -7.22603981813 -42.8400942016 1.28492929317 -7.22703981813 -42.8400942016 1.28492929317 -7.22803981813 -42.8400942016 1.28492929317 -7.22903981813 -42.8400942016 1.28492929317 -7.23003981813 -42.8400942016 1.28492929317 -7.23103981813 -42.8400942016 1.28492929317 -7.23203981813 -42.8400942016 1.28492929317 -7.23303981813 -42.8400942016 1.28492929317 -7.23403981813 -42.8400942016 1.28492929317 -7.23503981813 -42.8400942016 1.28492929317 -7.23603981813 -42.8400942016 1.28492929317 -7.23703981813 -42.8400942016 1.28492929317 -7.23803981813 -42.8400942016 1.28492929317 -7.23903981813 -42.8400942016 1.28492929317 -7.24003981813 -42.8400942016 1.28492929317 -7.24103981813 -42.8400942016 1.28492929317 -7.24203981813 -42.8400942016 1.28492929317 -7.24303981813 -42.8400942016 1.28492929317 -7.24403981813 -42.8400942016 1.28492929317 -7.24503981813 -42.8400942016 1.28492929317 -7.24603981813 -42.8400942016 1.28492929317 -7.24703981813 -42.8400942016 1.28492929317 -7.24803981813 -42.8400942016 1.28492929317 -7.24903981813 -42.8400942016 1.28492929317 -7.25003981813 -42.8400942016 1.28492929317 -7.25103981813 -42.8400942016 1.28492929317 -7.25203981813 -42.8400942016 1.28492929317 -7.25303981813 -42.8400942016 1.28492929317 -7.25403981813 -42.8400942016 1.28492929317 -7.25503981813 -42.8400942016 1.28492929317 -7.25603981813 -42.8400942016 1.28492929317 -7.25703981813 -42.8400942016 1.28492929317 -7.25803981813 -42.8400942016 1.28492929317 -7.25903981813 -42.8400942016 1.28492929317 -7.26003981813 -42.8400942016 1.28492929317 -7.26103981813 -42.8400942016 1.28492929317 -7.26203981813 -42.8400942016 1.28492929317 -7.26303981813 -42.8400942016 1.28492929317 -7.26403981813 -42.8400942016 1.28492929317 -7.26503981813 -42.8400942016 1.28492929317 -7.26603981813 -42.8400942016 1.28492929317 -7.26703981813 -42.8400942016 1.28492929317 -7.26803981813 -42.8400942016 1.28492929317 -7.26903981813 -42.8400942016 1.28492929317 -7.27003981813 -42.8400942016 1.28492929317 -7.27103981813 -42.8400942016 1.28492929317 -7.27203981813 -42.8400942016 1.28492929317 -7.27303981813 -42.8400942016 1.28492929317 -7.27403981813 -42.8400942016 1.28492929317 -7.27503981813 -42.8400942016 1.28492929317 -7.27603981813 -42.8400942016 1.28492929317 -7.27703981813 -42.8400942016 1.28492929317 -7.27803981813 -42.8400942016 1.28492929317 -7.27903981813 -42.8400942016 1.28492929317 -7.28003981813 -42.8400942016 1.28492929317 -7.28103981813 -42.8400942016 1.28492929317 -7.28203981813 -42.8400942016 1.28492929317 -7.28303981813 -42.8400942016 1.28492929317 -7.28403981813 -42.8400942016 1.28492929317 -7.28503981813 -42.8400942016 1.28492929317 -7.28603981813 -42.8400942016 1.28492929317 -7.28703981813 -42.8400942016 1.28492929317 -7.28803981813 -42.8400942016 1.28492929317 -7.28903981813 -42.8400942016 1.28492929317 -7.29003981813 -42.8400942016 1.28492929317 -7.29103981813 -42.8400942016 1.28492929317 -7.29203981813 -42.8400942016 1.28492929317 -7.29303981813 -42.8400942016 1.28492929317 -7.29403981813 -42.8400942016 1.28492929317 -7.29503981813 -42.8400942016 1.28492929317 -7.29603981813 -42.8400942016 1.28492929317 -7.29703981813 -42.8400942016 1.28492929317 -7.29803981813 -42.8400942016 1.28492929317 -7.29903981813 -42.8400942016 1.28492929317 -7.30003981813 -42.8400942016 1.28492929317 -7.30103981813 -42.8400942016 1.28492929317 -7.30203981813 -42.8400942016 1.28492929317 -7.30303981813 -42.8400942016 1.28492929317 -7.30403981813 -42.8400942016 1.28492929317 -7.30503981813 -42.8400942016 1.28492929317 -7.30603981813 -42.8400942016 1.28492929317 -7.30703981813 -42.8400942016 1.28492929317 -7.30803981813 -42.8400942016 1.28492929317 -7.30903981813 -42.8400942016 1.28492929317 -7.31003981813 -42.8400942016 1.28492929317 -7.31103981813 -42.8400942016 1.28492929317 -7.31203981813 -42.8400942016 1.28492929317 -7.31303981813 -42.8400942016 1.28492929317 -7.31403981813 -42.8400942016 1.28492929317 -7.31503981813 -42.8400942016 1.28492929317 -7.31603981813 -42.8400942016 1.28492929317 -7.31703981813 -42.8400942016 1.28492929317 -7.31803981813 -42.8400942016 1.28492929317 -7.31903981813 -42.8400942016 1.28492929317 -7.32003981813 -42.8400942016 1.28492929317 -7.32103981813 -42.8400942016 1.28492929317 -7.32203981813 -42.8400942016 1.28492929317 -7.32303981813 -42.8400942016 1.28492929317 -7.32403981813 -42.8400942016 1.28492929317 -7.32503981813 -42.8400942016 1.28492929317 -7.32603981813 -42.8400942016 1.28492929317 -7.32703981813 -42.8400942016 1.28492929317 -7.32803981813 -42.8400942016 1.28492929317 -7.32903981813 -42.8400942016 1.28492929317 -7.33003981813 -42.8400942016 1.28492929317 -7.33103981813 -42.8400942016 1.28492929317 -7.33203981813 -42.8400942016 1.28492929317 -7.33303981813 -42.8400942016 1.28492929317 -7.33403981813 -42.8400942016 1.28492929317 -7.33503981813 -42.8400942016 1.28492929317 -7.33603981813 -42.8400942016 1.28492929317 -7.33703981813 -42.8400942016 1.28492929317 -7.33803981813 -42.8400942016 1.28492929317 -7.33903981813 -42.8400942016 1.28492929317 -7.34003981813 -42.8400942016 1.28492929317 -7.34103981813 -42.8400942016 1.28492929317 -7.34203981813 -42.8400942016 1.28492929317 -7.34303981813 -42.8400942016 1.28492929317 -7.34403981813 -42.8400942016 1.28492929317 -7.34503981813 -42.8400942016 1.28492929317 -7.34603981813 -42.8400942016 1.28492929317 -7.34703981813 -42.8400942016 1.28492929317 -7.34803981813 -42.8400942016 1.28492929317 -7.34903981813 -42.8400942016 1.28492929317 -7.35003981813 -42.8400942016 1.28492929317 -7.35103981813 -42.8400942016 1.28492929317 -7.35203981813 -42.8400942016 1.28492929317 -7.35303981813 -42.8400942016 1.28492929317 -7.35403981813 -42.8400942016 1.28492929317 -7.35503981813 -42.8400942016 1.28492929317 -7.35603981813 -42.8400942016 1.28492929317 -7.35703981813 -42.8400942016 1.28492929317 -7.35803981813 -42.8400942016 1.28492929317 -7.35903981813 -42.8400942016 1.28492929317 -7.36003981813 -42.8400942016 1.28492929317 -7.36103981813 -42.8400942016 1.28492929317 -7.36203981813 -42.8400942016 1.28492929317 -7.36303981813 -42.8400942016 1.28492929317 -7.36403981813 -42.8400942016 1.28492929317 -7.36503981813 -42.8400942016 1.28492929317 -7.36603981813 -42.8400942016 1.28492929317 -7.36703981813 -42.8400942016 1.28492929317 -7.36803981813 -42.8400942016 1.28492929317 -7.36903981813 -42.8400942016 1.28492929317 -7.37003981813 -42.8400942016 1.28492929317 -7.37103981813 -42.8400942016 1.28492929317 -7.37203981813 -42.8400942016 1.28492929317 -7.37303981813 -42.8400942016 1.28492929317 -7.37403981813 -42.8400942016 1.28492929317 -7.37503981813 -42.8400942016 1.28492929317 -7.37603981813 -42.8400942016 1.28492929317 -7.37703981813 -42.8400942016 1.28492929317 -7.37803981813 -42.8400942016 1.28492929317 -7.37903981813 -42.8400942016 1.28492929317 -7.38003981813 -42.8400942016 1.28492929317 -7.38103981813 -42.8400942016 1.28492929317 -7.38203981813 -42.8400942016 1.28492929317 -7.38303981813 -42.8400942016 1.28492929317 -7.38403981813 -42.8400942016 1.28492929317 -7.38503981813 -42.8400942016 1.28492929317 -7.38603981813 -42.8400942016 1.28492929317 -7.38703981813 -42.8400942016 1.28492929317 -7.38803981813 -42.8400942016 1.28492929317 -7.38903981813 -42.8400942016 1.28492929317 -7.39003981813 -42.8400942016 1.28492929317 -7.39103981813 -42.8400942016 1.28492929317 -7.39203981813 -42.8400942016 1.28492929317 -7.39303981813 -42.8400942016 1.28492929317 -7.39403981813 -42.8400942016 1.28492929317 -7.39503981813 -42.8400942016 1.28492929317 -7.39603981813 -42.8400942016 1.28492929317 -7.39703981813 -42.8400942016 1.28492929317 -7.39803981813 -42.8400942016 1.28492929317 -7.39903981813 -42.8400942016 1.28492929317 -7.40003981813 -42.8400942016 1.28492929317 -7.40103981813 -42.8400942016 1.28492929317 -7.40203981813 -42.8400942016 1.28492929317 -7.40303981813 -42.8400942016 1.28492929317 -7.40403981813 -42.8400942016 1.28492929317 -7.40503981813 -42.8400942016 1.28492929317 -7.40603981813 -42.8400942016 1.28492929317 -7.40703981813 -42.8400942016 1.28492929317 -7.40803981813 -42.8400942016 1.28492929317 -7.40903981813 -42.8400942016 1.28492929317 -7.41003981813 -42.8400942016 1.28492929317 -7.41103981813 -42.8400942016 1.28492929317 -7.41203981813 -42.8400942016 1.28492929317 -7.41303981813 -42.8400942016 1.28492929317 -7.41403981813 -42.8400942016 1.28492929317 -7.41503981813 -42.8400942016 1.28492929317 -7.41603981813 -42.8400942016 1.28492929317 -7.41703981813 -42.8400942016 1.28492929317 -7.41803981813 -42.8400942016 1.28492929317 -7.41903981813 -42.8400942016 1.28492929317 -7.42003981813 -42.8400942016 1.28492929317 -7.42103981813 -42.8400942016 1.28492929317 -7.42203981813 -42.8400942016 1.28492929317 -7.42303981813 -42.8400942016 1.28492929317 -7.42403981813 -42.8400942016 1.28492929317 -7.42503981813 -42.8400942016 1.28492929317 -7.42603981813 -42.8400942016 1.28492929317 -7.42703981813 -42.8400942016 1.28492929317 -7.42803981813 -42.8400942016 1.28492929317 -7.42903981813 -42.8400942016 1.28492929317 -7.43003981813 -42.8400942016 1.28492929317 -7.43103981813 -42.8400942016 1.28492929317 -7.43203981813 -42.8400942016 1.28492929317 -7.43303981813 -42.8400942016 1.28492929317 -7.43403981813 -42.8400942016 1.28492929317 -7.43503981813 -42.8400942016 1.28492929317 -7.43603981813 -42.8400942016 1.28492929317 -7.43703981813 -42.8400942016 1.28492929317 -7.43803981813 -42.8400942016 1.28492929317 -7.43903981813 -42.8400942016 1.28492929317 -7.44003981813 -42.8400942016 1.28492929317 -7.44103981813 -42.8400942016 1.28492929317 -7.44203981813 -42.8400942016 1.28492929317 -7.44303981813 -42.8400942016 1.28492929317 -7.44403981813 -42.8400942016 1.28492929317 -7.44503981813 -42.8400942016 1.28492929317 -7.44603981813 -42.8400942016 1.28492929317 -7.44703981813 -42.8400942016 1.28492929317 -7.44803981813 -42.8400942016 1.28492929317 -7.44903981813 -42.8400942016 1.28492929317 -7.45003981813 -42.8400942016 1.28492929317 -7.45103981813 -42.8400942016 1.28492929317 -7.45203981813 -42.8400942016 1.28492929317 -7.45303981813 -42.8400942016 1.28492929317 -7.45403981813 -42.8400942016 1.28492929317 -7.45503981813 -42.8400942016 1.28492929317 -7.45603981813 -42.8400942016 1.28492929317 -7.45703981813 -42.8400942016 1.28492929317 -7.45803981813 -42.8400942016 1.28492929317 -7.45903981813 -42.8400942016 1.28492929317 -7.46003981813 -42.8400942016 1.28492929317 -7.46103981813 -42.8400942016 1.28492929317 -7.46203981813 -42.8400942016 1.28492929317 -7.46303981813 -42.8400942016 1.28492929317 -7.46403981813 -42.8400942016 1.28492929317 -7.46503981813 -42.8400942016 1.28492929317 -7.46603981813 -42.8400942016 1.28492929317 -7.46703981813 -42.8400942016 1.28492929317 -7.46803981813 -42.8400942016 1.28492929317 -7.46903981813 -42.8400942016 1.28492929317 -7.47003981813 -42.8400942016 1.28492929317 -7.47103981813 -42.8400942016 1.28492929317 -7.47203981813 -42.8400942016 1.28492929317 -7.47303981813 -42.8400942016 1.28492929317 -7.47403981813 -42.8400942016 1.28492929317 -7.47503981813 -42.8400942016 1.28492929317 -7.47603981813 -42.8400942016 1.28492929317 -7.47703981813 -42.8400942016 1.28492929317 -7.47803981813 -42.8400942016 1.28492929317 -7.47903981813 -42.8400942016 1.28492929317 -7.48003981813 -42.8400942016 1.28492929317 -7.48103981813 -42.8400942016 1.28492929317 -7.48203981813 -42.8400942016 1.28492929317 -7.48303981813 -42.8400942016 1.28492929317 -7.48403981813 -42.8400942016 1.28492929317 -7.48503981813 -42.8400942016 1.28492929317 -7.48603981813 -42.8400942016 1.28492929317 -7.48703981813 -42.8400942016 1.28492929317 -7.48803981813 -42.8400942016 1.28492929317 -7.48903981813 -42.8400942016 1.28492929317 -7.49003981813 -42.8400942016 1.28492929317 -7.49103981813 -42.8400942016 1.28492929317 -7.49203981813 -42.8400942016 1.28492929317 -7.49303981813 -42.8400942016 1.28492929317 -7.49403981813 -42.8400942016 1.28492929317 -7.49503981813 -42.8400942016 1.28492929317 -7.49603981813 -42.8400942016 1.28492929317 -7.49703981813 -42.8400942016 1.28492929317 -7.49803981813 -42.8400942016 1.28492929317 -7.49903981813 -42.8400942016 1.28492929317 -7.50003981813 -42.8400942016 1.28492929317 -7.50103981813 -42.8400942016 1.28492929317 -7.50203981813 -42.8400942016 1.28492929317 -7.50303981813 -42.8400942016 1.28492929317 -7.50403981813 -42.8400942016 1.28492929317 -7.50503981813 -42.8400942016 1.28492929317 -7.50603981813 -42.8400942016 1.28492929317 -7.50703981813 -42.8400942016 1.28492929317 -7.50803981813 -42.8400942016 1.28492929317 -7.50903981813 -42.8400942016 1.28492929317 -7.51003981813 -42.8400942016 1.28492929317 -7.51103981813 -42.8400942016 1.28492929317 -7.51203981813 -42.8400942016 1.28492929317 -7.51303981813 -42.8400942016 1.28492929317 -7.51403981813 -42.8400942016 1.28492929317 -7.51503981813 -42.8400942016 1.28492929317 -7.51603981813 -42.8400942016 1.28492929317 -7.51703981813 -42.8400942016 1.28492929317 -7.51803981813 -42.8400942016 1.28492929317 -7.51903981813 -42.8400942016 1.28492929317 -7.52003981813 -42.8400942016 1.28492929317 -7.52103981813 -42.8400942016 1.28492929317 -7.52203981813 -42.8400942016 1.28492929317 -7.52303981813 -42.8400942016 1.28492929317 -7.52403981813 -42.8400942016 1.28492929317 -7.52503981813 -42.8400942016 1.28492929317 -7.52603981813 -42.8400942016 1.28492929317 -7.52703981813 -42.8400942016 1.28492929317 -7.52803981813 -42.8400942016 1.28492929317 -7.52903981813 -42.8400942016 1.28492929317 -7.53003981813 -42.8400942016 1.28492929317 -7.53103981813 -42.8400942016 1.28492929317 -7.53203981813 -42.8400942016 1.28492929317 -7.53303981813 -42.8400942016 1.28492929317 -7.53403981813 -42.8400942016 1.28492929317 -7.53503981813 -42.8400942016 1.28492929317 -7.53603981813 -42.8400942016 1.28492929317 -7.53703981813 -42.8400942016 1.28492929317 -7.53803981813 -42.8400942016 1.28492929317 -7.53903981813 -42.8400942016 1.28492929317 -7.54003981813 -42.8400942016 1.28492929317 -7.54103981813 -42.8400942016 1.28492929317 -7.54203981813 -42.8400942016 1.28492929317 -7.54303981813 -42.8400942016 1.28492929317 -7.54403981813 -42.8400942016 1.28492929317 -7.54503981813 -42.8400942016 1.28492929317 -7.54603981813 -42.8400942016 1.28492929317 -7.54703981813 -42.8400942016 1.28492929317 -7.54803981813 -42.8400942016 1.28492929317 -7.54903981813 -42.8400942016 1.28492929317 -7.55003981813 -42.8400942016 1.28492929317 -7.55103981813 -42.8400942016 1.28492929317 -7.55203981813 -42.8400942016 1.28492929317 -7.55303981813 -42.8400942016 1.28492929317 -7.55403981813 -42.8400942016 1.28492929317 -7.55503981813 -42.8400942016 1.28492929317 -7.55603981813 -42.8400942016 1.28492929317 -7.55703981813 -42.8400942016 1.28492929317 -7.55803981813 -42.8400942016 1.28492929317 -7.55903981813 -42.8400942016 1.28492929317 -7.56003981813 -42.8400942016 1.28492929317 -7.56103981813 -42.8400942016 1.28492929317 -7.56203981813 -42.8400942016 1.28492929317 -7.56303981813 -42.8400942016 1.28492929317 -7.56403981813 -42.8400942016 1.28492929317 -7.56503981813 -42.8400942016 1.28492929317 -7.56603981813 -42.8400942016 1.28492929317 -7.56703981813 -42.8400942016 1.28492929317 -7.56803981813 -42.8400942016 1.28492929317 -7.56903981813 -42.8400942016 1.28492929317 -7.57003981813 -42.8400942016 1.28492929317 -7.57103981813 -42.8400942016 1.28492929317 -7.57203981813 -42.8400942016 1.28492929317 -7.57303981813 -42.8400942016 1.28492929317 -7.57403981813 -42.8400942016 1.28492929317 -7.57503981813 -42.8400942016 1.28492929317 -7.57603981813 -42.8400942016 1.28492929317 -7.57703981813 -42.8400942016 1.28492929317 -7.57803981813 -42.8400942016 1.28492929317 -7.57903981813 -42.8400942016 1.28492929317 -7.58003981813 -42.8400942016 1.28492929317 -7.58103981813 -42.8400942016 1.28492929317 -7.58203981813 -42.8400942016 1.28492929317 -7.58303981813 -42.8400942016 1.28492929317 -7.58403981813 -42.8400942016 1.28492929317 -7.58503981813 -42.8400942016 1.28492929317 -7.58603981813 -42.8400942016 1.28492929317 -7.58703981813 -42.8400942016 1.28492929317 -7.58803981813 -42.8400942016 1.28492929317 -7.58903981813 -42.8400942016 1.28492929317 -7.59003981813 -42.8400942016 1.28492929317 -7.59103981813 -42.8400942016 1.28492929317 -7.59203981813 -42.8400942016 1.28492929317 -7.59303981813 -42.8400942016 1.28492929317 -7.59403981813 -42.8400942016 1.28492929317 -7.59503981813 -42.8400942016 1.28492929317 -7.59603981813 -42.8400942016 1.28492929317 -7.59703981813 -42.8400942016 1.28492929317 -7.59803981813 -42.8400942016 1.28492929317 -7.59903981813 -42.8400942016 1.28492929317 -7.60003981813 -42.8400942016 1.28492929317 -7.60103981813 -42.8400942016 1.28492929317 -7.60203981813 -42.8400942016 1.28492929317 -7.60303981813 -42.8400942016 1.28492929317 -7.60403981813 -42.8400942016 1.28492929317 -7.60503981813 -42.8400942016 1.28492929317 -7.60603981813 -42.8400942016 1.28492929317 -7.60703981813 -42.8400942016 1.28492929317 -7.60803981813 -42.8400942016 1.28492929317 -7.60903981813 -42.8400942016 1.28492929317 -7.61003981813 -42.8400942016 1.28492929317 -7.61103981813 -42.8400942016 1.28492929317 -7.61203981813 -42.8400942016 1.28492929317 -7.61303981813 -42.8400942016 1.28492929317 -7.61403981813 -42.8400942016 1.28492929317 -7.61503981813 -42.8400942016 1.28492929317 -7.61603981813 -42.8400942016 1.28492929317 -7.61703981813 -42.8400942016 1.28492929317 -7.61803981813 -42.8400942016 1.28492929317 -7.61903981813 -42.8400942016 1.28492929317 -7.62003981813 -42.8400942016 1.28492929317 -7.62103981813 -42.8400942016 1.28492929317 -7.62203981813 -42.8400942016 1.28492929317 -7.62303981813 -42.8400942016 1.28492929317 -7.62403981813 -42.8400942016 1.28492929317 -7.62503981813 -42.8400942016 1.28492929317 -7.62603981813 -42.8400942016 1.28492929317 -7.62703981813 -42.8400942016 1.28492929317 -7.62803981813 -42.8400942016 1.28492929317 -7.62903981813 -42.8400942016 1.28492929317 -7.63003981813 -42.8400942016 1.28492929317 -7.63103981813 -42.8400942016 1.28492929317 -7.63203981813 -42.8400942016 1.28492929317 -7.63303981813 -42.8400942016 1.28492929317 -7.63403981813 -42.8400942016 1.28492929317 -7.63503981813 -42.8400942016 1.28492929317 -7.63603981813 -42.8400942016 1.28492929317 -7.63703981813 -42.8400942016 1.28492929317 -7.63803981813 -42.8400942016 1.28492929317 -7.63903981813 -42.8400942016 1.28492929317 -7.64003981813 -42.8400942016 1.28492929317 -7.64103981813 -42.8400942016 1.28492929317 -7.64203981813 -42.8400942016 1.28492929317 -7.64303981813 -42.8400942016 1.28492929317 -7.64403981813 -42.8400942016 1.28492929317 -7.64503981813 -42.8400942016 1.28492929317 -7.64603981813 -42.8400942016 1.28492929317 -7.64703981813 -42.8400942016 1.28492929317 -7.64803981813 -42.8400942016 1.28492929317 -7.64903981813 -42.8400942016 1.28492929317 -7.65003981813 -42.8400942016 1.28492929317 -7.65103981813 -42.8400942016 1.28492929317 -7.65203981813 -42.8400942016 1.28492929317 -7.65303981813 -42.8400942016 1.28492929317 -7.65403981813 -42.8400942016 1.28492929317 -7.65503981813 -42.8400942016 1.28492929317 -7.65603981813 -42.8400942016 1.28492929317 -7.65703981813 -42.8400942016 1.28492929317 -7.65803981813 -42.8400942016 1.28492929317 -7.65903981813 -42.8400942016 1.28492929317 -7.66003981813 -42.8400942016 1.28492929317 -7.66103981813 -42.8400942016 1.28492929317 -7.66203981813 -42.8400942016 1.28492929317 -7.66303981813 -42.8400942016 1.28492929317 -7.66403981813 -42.8400942016 1.28492929317 -7.66503981813 -42.8400942016 1.28492929317 -7.66603981813 -42.8400942016 1.28492929317 -7.66703981813 -42.8400942016 1.28492929317 -7.66803981813 -42.8400942016 1.28492929317 -7.66903981813 -42.8400942016 1.28492929317 -7.67003981813 -42.8400942016 1.28492929317 -7.67103981813 -42.8400942016 1.28492929317 -7.67203981813 -42.8400942016 1.28492929317 -7.67303981813 -42.8400942016 1.28492929317 -7.67403981813 -42.8400942016 1.28492929317 -7.67503981813 -42.8400942016 1.28492929317 -7.67603981813 -42.8400942016 1.28492929317 -7.67703981813 -42.8400942016 1.28492929317 -7.67803981813 -42.8400942016 1.28492929317 -7.67903981813 -42.8400942016 1.28492929317 -7.68003981813 -42.8400942016 1.28492929317 -7.68103981813 -42.8400942016 1.28492929317 -7.68203981813 -42.8400942016 1.28492929317 -7.68303981813 -42.8400942016 1.28492929317 -7.68403981813 -42.8400942016 1.28492929317 -7.68503981813 -42.8400942016 1.28492929317 -7.68603981813 -42.8400942016 1.28492929317 -7.68703981813 -42.8400942016 1.28492929317 -7.68803981813 -42.8400942016 1.28492929317 -7.68903981813 -42.8400942016 1.28492929317 -7.69003981813 -42.8400942016 1.28492929317 -7.69103981813 -42.8400942016 1.28492929317 -7.69203981813 -42.8400942016 1.28492929317 -7.69303981813 -42.8400942016 1.28492929317 -7.69403981813 -42.8400942016 1.28492929317 -7.69503981813 -42.8400942016 1.28492929317 -7.69603981813 -42.8400942016 1.28492929317 -7.69703981813 -42.8400942016 1.28492929317 -7.69803981813 -42.8400942016 1.28492929317 -7.69903981813 -42.8400942016 1.28492929317 -7.70003981813 -42.8400942016 1.28492929317 -7.70103981813 -42.8400942016 1.28492929317 -7.70203981813 -42.8400942016 1.28492929317 -7.70303981813 -42.8400942016 1.28492929317 -7.70403981813 -42.8400942016 1.28492929317 -7.70503981813 -42.8400942016 1.28492929317 -7.70603981813 -42.8400942016 1.28492929317 -7.70703981813 -42.8400942016 1.28492929317 -7.70803981813 -42.8400942016 1.28492929317 -7.70903981813 -42.8400942016 1.28492929317 -7.71003981813 -42.8400942016 1.28492929317 -7.71103981813 -42.8400942016 1.28492929317 -7.71203981813 -42.8400942016 1.28492929317 -7.71303981813 -42.8400942016 1.28492929317 -7.71403981813 -42.8400942016 1.28492929317 -7.71503981813 -42.8400942016 1.28492929317 -7.71603981813 -42.8400942016 1.28492929317 -7.71703981813 -42.8400942016 1.28492929317 -7.71803981813 -42.8400942016 1.28492929317 -7.71903981813 -42.8400942016 1.28492929317 -7.72003981813 -42.8400942016 1.28492929317 -7.72103981813 -42.8400942016 1.28492929317 -7.72203981813 -42.8400942016 1.28492929317 -7.72303981813 -42.8400942016 1.28492929317 -7.72403981813 -42.8400942016 1.28492929317 -7.72503981813 -42.8400942016 1.28492929317 -7.72603981813 -42.8400942016 1.28492929317 -7.72703981813 -42.8400942016 1.28492929317 -7.72803981813 -42.8400942016 1.28492929317 -7.72903981813 -42.8400942016 1.28492929317 -7.73003981813 -42.8400942016 1.28492929317 -7.73103981813 -42.8400942016 1.28492929317 -7.73203981813 -42.8400942016 1.28492929317 -7.73303981813 -42.8400942016 1.28492929317 -7.73403981813 -42.8400942016 1.28492929317 -7.73503981813 -42.8400942016 1.28492929317 -7.73603981813 -42.8400942016 1.28492929317 -7.73703981813 -42.8400942016 1.28492929317 -7.73803981813 -42.8400942016 1.28492929317 -7.73903981813 -42.8400942016 1.28492929317 -7.74003981813 -42.8400942016 1.28492929317 -7.74103981813 -42.8400942016 1.28492929317 -7.74203981813 -42.8400942016 1.28492929317 -7.74303981813 -42.8400942016 1.28492929317 -7.74403981813 -42.8400942016 1.28492929317 -7.74503981813 -42.8400942016 1.28492929317 -7.74603981813 -42.8400942016 1.28492929317 -7.74703981813 -42.8400942016 1.28492929317 -7.74803981813 -42.8400942016 1.28492929317 -7.74903981813 -42.8400942016 1.28492929317 -7.75003981813 -42.8400942016 1.28492929317 -7.75103981813 -42.8400942016 1.28492929317 -7.75203981813 -42.8400942016 1.28492929317 -7.75303981813 -42.8400942016 1.28492929317 -7.75403981813 -42.8400942016 1.28492929317 -7.75503981813 -42.8400942016 1.28492929317 -7.75603981813 -42.8400942016 1.28492929317 -7.75703981813 -42.8400942016 1.28492929317 -7.75803981813 -42.8400942016 1.28492929317 -7.75903981813 -42.8400942016 1.28492929317 -7.76003981813 -42.8400942016 1.28492929317 -7.76103981813 -42.8400942016 1.28492929317 -7.76203981813 -42.8400942016 1.28492929317 -7.76303981813 -42.8400942016 1.28492929317 -7.76403981813 -42.8400942016 1.28492929317 -7.76503981813 -42.8400942016 1.28492929317 -7.76603981813 -42.8400942016 1.28492929317 -7.76703981813 -42.8400942016 1.28492929317 -7.76803981813 -42.8400942016 1.28492929317 -7.76903981813 -42.8400942016 1.28492929317 -7.77003981813 -42.8400942016 1.28492929317 -7.77103981813 -42.8400942016 1.28492929317 -7.77203981813 -42.8400942016 1.28492929317 -7.77303981813 -42.8400942016 1.28492929317 -7.77403981813 -42.8400942016 1.28492929317 -7.77503981813 -42.8400942016 1.28492929317 -7.77603981813 -42.8400942016 1.28492929317 -7.77703981813 -42.8400942016 1.28492929317 -7.77803981813 -42.8400942016 1.28492929317 -7.77903981813 -42.8400942016 1.28492929317 -7.78003981813 -42.8400942016 1.28492929317 -7.78103981813 -42.8400942016 1.28492929317 -7.78203981813 -42.8400942016 1.28492929317 -7.78303981813 -42.8400942016 1.28492929317 -7.78403981813 -42.8400942016 1.28492929317 -7.78503981813 -42.8400942016 1.28492929317 -7.78603981813 -42.8400942016 1.28492929317 -7.78703981813 -42.8400942016 1.28492929317 -7.78803981813 -42.8400942016 1.28492929317 -7.78903981813 -42.8400942016 1.28492929317 -7.79003981813 -42.8400942016 1.28492929317 -7.79103981813 -42.8400942016 1.28492929317 -7.79203981813 -42.8400942016 1.28492929317 -7.79303981813 -42.8400942016 1.28492929317 -7.79403981813 -42.8400942016 1.28492929317 -7.79503981813 -42.8400942016 1.28492929317 -7.79603981813 -42.8400942016 1.28492929317 -7.79703981813 -42.8400942016 1.28492929317 -7.79803981813 -42.8400942016 1.28492929317 -7.79903981813 -42.8400942016 1.28492929317 -7.80003981813 -42.8400942016 1.28492929317 -7.80103981813 -42.8400942016 1.28492929317 -7.80203981813 -42.8400942016 1.28492929317 -7.80303981813 -42.8400942016 1.28492929317 -7.80403981813 -42.8400942016 1.28492929317 -7.80503981813 -42.8400942016 1.28492929317 -7.80603981813 -42.8400942016 1.28492929317 -7.80703981813 -42.8400942016 1.28492929317 -7.80803981813 -42.8400942016 1.28492929317 -7.80903981813 -42.8400942016 1.28492929317 -7.81003981813 -42.8400942016 1.28492929317 -7.81103981813 -42.8400942016 1.28492929317 -7.81203981813 -42.8400942016 1.28492929317 -7.81303981813 -42.8400942016 1.28492929317 -7.81403981813 -42.8400942016 1.28492929317 -7.81503981813 -42.8400942016 1.28492929317 -7.81603981813 -42.8400942016 1.28492929317 -7.81703981813 -42.8400942016 1.28492929317 -7.81803981813 -42.8400942016 1.28492929317 -7.81903981813 -42.8400942016 1.28492929317 -7.82003981813 -42.8400942016 1.28492929317 -7.82103981813 -42.8400942016 1.28492929317 -7.82203981813 -42.8400942016 1.28492929317 -7.82303981813 -42.8400942016 1.28492929317 -7.82403981813 -42.8400942016 1.28492929317 -7.82503981813 -42.8400942016 1.28492929317 -7.82603981813 -42.8400942016 1.28492929317 -7.82703981813 -42.8400942016 1.28492929317 -7.82803981813 -42.8400942016 1.28492929317 -7.82903981813 -42.8400942016 1.28492929317 -7.83003981813 -42.8400942016 1.28492929317 -7.83103981813 -42.8400942016 1.28492929317 -7.83203981813 -42.8400942016 1.28492929317 -7.83303981813 -42.8400942016 1.28492929317 -7.83403981813 -42.8400942016 1.28492929317 -7.83503981813 -42.8400942016 1.28492929317 -7.83603981813 -42.8400942016 1.28492929317 -7.83703981813 -42.8400942016 1.28492929317 -7.83803981813 -42.8400942016 1.28492929317 -7.83903981813 -42.8400942016 1.28492929317 -7.84003981813 -42.8400942016 1.28492929317 -7.84103981813 -42.8400942016 1.28492929317 -7.84203981813 -42.8400942016 1.28492929317 -7.84303981813 -42.8400942016 1.28492929317 -7.84403981813 -42.8400942016 1.28492929317 -7.84503981813 -42.8400942016 1.28492929317 -7.84603981813 -42.8400942016 1.28492929317 -7.84703981813 -42.8400942016 1.28492929317 -7.84803981813 -42.8400942016 1.28492929317 -7.84903981813 -42.8400942016 1.28492929317 -7.85003981813 -42.8400942016 1.28492929317 -7.85103981813 -42.8400942016 1.28492929317 -7.85203981813 -42.8400942016 1.28492929317 -7.85303981813 -42.8400942016 1.28492929317 -7.85403981813 -42.8400942016 1.28492929317 -7.85503981813 -42.8400942016 1.28492929317 -7.85603981813 -42.8400942016 1.28492929317 -7.85703981813 -42.8400942016 1.28492929317 -7.85803981813 -42.8400942016 1.28492929317 -7.85903981813 -42.8400942016 1.28492929317 -7.86003981813 -42.8400942016 1.28492929317 -7.86103981813 -42.8400942016 1.28492929317 -7.86203981813 -42.8400942016 1.28492929317 -7.86303981813 -42.8400942016 1.28492929317 -7.86403981813 -42.8400942016 1.28492929317 -7.86503981813 -42.8400942016 1.28492929317 -7.86603981813 -42.8400942016 1.28492929317 -7.86703981813 -42.8400942016 1.28492929317 -7.86803981813 -42.8400942016 1.28492929317 -7.86903981813 -42.8400942016 1.28492929317 -7.87003981813 -42.8400942016 1.28492929317 -7.87103981813 -42.8400942016 1.28492929317 -7.87203981813 -42.8400942016 1.28492929317 -7.87303981813 -42.8400942016 1.28492929317 -7.87403981813 -42.8400942016 1.28492929317 -7.87503981813 -42.8400942016 1.28492929317 -7.87603981813 -42.8400942016 1.28492929317 -7.87703981813 -42.8400942016 1.28492929317 -7.87803981813 -42.8400942016 1.28492929317 -7.87903981813 -42.8400942016 1.28492929317 -7.88003981813 -42.8400942016 1.28492929317 -7.88103981813 -42.8400942016 1.28492929317 -7.88203981813 -42.8400942016 1.28492929317 -7.88303981813 -42.8400942016 1.28492929317 -7.88403981813 -42.8400942016 1.28492929317 -7.88503981813 -42.8400942016 1.28492929317 -7.88603981813 -42.8400942016 1.28492929317 -7.88703981813 -42.8400942016 1.28492929317 -7.88803981813 -42.8400942016 1.28492929317 -7.88903981813 -42.8400942016 1.28492929317 -7.89003981813 -42.8400942016 1.28492929317 -7.89103981813 -42.8400942016 1.28492929317 -7.89203981813 -42.8400942016 1.28492929317 -7.89303981813 -42.8400942016 1.28492929317 -7.89403981813 -42.8400942016 1.28492929317 -7.89503981813 -42.8400942016 1.28492929317 -7.89603981813 -42.8400942016 1.28492929317 -7.89703981813 -42.8400942016 1.28492929317 -7.89803981813 -42.8400942016 1.28492929317 -7.89903981813 -42.8400942016 1.28492929317 -7.90003981813 -42.8400942016 1.28492929317 -7.90103981813 -42.8400942016 1.28492929317 -7.90203981813 -42.8400942016 1.28492929317 -7.90303981813 -42.8400942016 1.28492929317 -7.90403981813 -42.8400942016 1.28492929317 -7.90503981813 -42.8400942016 1.28492929317 -7.90603981813 -42.8400942016 1.28492929317 -7.90703981813 -42.8400942016 1.28492929317 -7.90803981813 -42.8400942016 1.28492929317 -7.90903981813 -42.8400942016 1.28492929317 -7.91003981813 -42.8400942016 1.28492929317 -7.91103981813 -42.8400942016 1.28492929317 -7.91203981813 -42.8400942016 1.28492929317 -7.91303981813 -42.8400942016 1.28492929317 -7.91403981813 -42.8400942016 1.28492929317 -7.91503981813 -42.8400942016 1.28492929317 -7.91603981813 -42.8400942016 1.28492929317 -7.91703981813 -42.8400942016 1.28492929317 -7.91803981813 -42.8400942016 1.28492929317 -7.91903981813 -42.8400942016 1.28492929317 -7.92003981813 -42.8400942016 1.28492929317 -7.92103981813 -42.8400942016 1.28492929317 -7.92203981813 -42.8400942016 1.28492929317 -7.92303981813 -42.8400942016 1.28492929317 -7.92403981813 -42.8400942016 1.28492929317 -7.92503981813 -42.8400942016 1.28492929317 -7.92603981813 -42.8400942016 1.28492929317 -7.92703981813 -42.8400942016 1.28492929317 -7.92803981813 -42.8400942016 1.28492929317 -7.92903981813 -42.8400942016 1.28492929317 -7.93003981813 -42.8400942016 1.28492929317 -7.93103981813 -42.8400942016 1.28492929317 -7.93203981813 -42.8400942016 1.28492929317 -7.93303981813 -42.8400942016 1.28492929317 -7.93403981813 -42.8400942016 1.28492929317 -7.93503981813 -42.8400942016 1.28492929317 -7.93603981813 -42.8400942016 1.28492929317 -7.93703981813 -42.8400942016 1.28492929317 -7.93803981813 -42.8400942016 1.28492929317 -7.93903981813 -42.8400942016 1.28492929317 -7.94003981813 -42.8400942016 1.28492929317 -7.94103981813 -42.8400942016 1.28492929317 -7.94203981813 -42.8400942016 1.28492929317 -7.94303981813 -42.8400942016 1.28492929317 -7.94403981813 -42.8400942016 1.28492929317 -7.94503981813 -42.8400942016 1.28492929317 -7.94603981813 -42.8400942016 1.28492929317 -7.94703981813 -42.8400942016 1.28492929317 -7.94803981813 -42.8400942016 1.28492929317 -7.94903981813 -42.8400942016 1.28492929317 -7.95003981813 -42.8400942016 1.28492929317 -7.95103981813 -42.8400942016 1.28492929317 -7.95203981813 -42.8400942016 1.28492929317 -7.95303981813 -42.8400942016 1.28492929317 -7.95403981813 -42.8400942016 1.28492929317 -7.95503981813 -42.8400942016 1.28492929317 -7.95603981813 -42.8400942016 1.28492929317 -7.95703981813 -42.8400942016 1.28492929317 -7.95803981813 -42.8400942016 1.28492929317 -7.95903981813 -42.8400942016 1.28492929317 -7.96003981813 -42.8400942016 1.28492929317 -7.96103981813 -42.8400942016 1.28492929317 -7.96203981813 -42.8400942016 1.28492929317 -7.96303981813 -42.8400942016 1.28492929317 -7.96403981813 -42.8400942016 1.28492929317 -7.96503981813 -42.8400942016 1.28492929317 -7.96603981813 -42.8400942016 1.28492929317 -7.96703981813 -42.8400942016 1.28492929317 -7.96803981813 -42.8400942016 1.28492929317 -7.96903981813 -42.8400942016 1.28492929317 -7.97003981813 -42.8400942016 1.28492929317 -7.97103981813 -42.8400942016 1.28492929317 -7.97203981813 -42.8400942016 1.28492929317 -7.97303981813 -42.8400942016 1.28492929317 -7.97403981813 -42.8400942016 1.28492929317 -7.97503981813 -42.8400942016 1.28492929317 -7.97603981813 -42.8400942016 1.28492929317 -7.97703981813 -42.8400942016 1.28492929317 -7.97803981813 -42.8400942016 1.28492929317 -7.97903981813 -42.8400942016 1.28492929317 -7.98003981813 -42.8400942016 1.28492929317 -7.98103981813 -42.8400942016 1.28492929317 -7.98203981813 -42.8400942016 1.28492929317 -7.98303981813 -42.8400942016 1.28492929317 -7.98403981813 -42.8400942016 1.28492929317 -7.98503981813 -42.8400942016 1.28492929317 -7.98603981813 -42.8400942016 1.28492929317 -7.98703981813 -42.8400942016 1.28492929317 -7.98803981813 -42.8400942016 1.28492929317 -7.98903981813 -42.8400942016 1.28492929317 -7.99003981813 -42.8400942016 1.28492929317 -7.99103981813 -42.8400942016 1.28492929317 -7.99203981813 -42.8400942016 1.28492929317 -7.99303981813 -42.8400942016 1.28492929317 -7.99403981813 -42.8400942016 1.28492929317 -7.99503981813 -42.8400942016 1.28492929317 -7.99603981813 -42.8400942016 1.28492929317 -7.99703981813 -42.8400942016 1.28492929317 -7.99803981813 -42.8400942016 1.28492929317 -7.99903981813 -42.8400942016 1.28492929317 -8.00003981813 -42.8400942016 1.28492929317 -8.00103981813 -42.8400942016 1.28492929317 -8.00203981813 -42.8400942016 1.28492929317 -8.00303981813 -42.8400942016 1.28492929317 -8.00403981813 -42.8400942016 1.28492929317 -8.00503981813 -42.8400942016 1.28492929317 -8.00603981813 -42.8400942016 1.28492929317 -8.00703981813 -42.8400942016 1.28492929317 -8.00803981813 -42.8400942016 1.28492929317 -8.00903981813 -42.8400942016 1.28492929317 -8.01003981813 -42.8400942016 1.28492929317 -8.01103981813 -42.8400942016 1.28492929317 -8.01203981813 -42.8400942016 1.28492929317 -8.01303981813 -42.8400942016 1.28492929317 -8.01403981813 -42.8400942016 1.28492929317 -8.01503981813 -42.8400942016 1.28492929317 -8.01603981813 -42.8400942016 1.28492929317 -8.01703981813 -42.8400942016 1.28492929317 -8.01803981813 -42.8400942016 1.28492929317 -8.01903981813 -42.8400942016 1.28492929317 -8.02003981813 -42.8400942016 1.28492929317 -8.02103981813 -42.8400942016 1.28492929317 -8.02203981813 -42.8400942016 1.28492929317 -8.02303981813 -42.8400942016 1.28492929317 -8.02403981813 -42.8400942016 1.28492929317 -8.02503981813 -42.8400942016 1.28492929317 -8.02603981813 -42.8400942016 1.28492929317 -8.02703981813 -42.8400942016 1.28492929317 -8.02803981813 -42.8400942016 1.28492929317 -8.02903981813 -42.8400942016 1.28492929317 -8.03003981813 -42.8400942016 1.28492929317 -8.03103981813 -42.8400942016 1.28492929317 -8.03203981813 -42.8400942016 1.28492929317 -8.03303981813 -42.8400942016 1.28492929317 -8.03403981813 -42.8400942016 1.28492929317 -8.03503981813 -42.8400942016 1.28492929317 -8.03603981813 -42.8400942016 1.28492929317 -8.03703981813 -42.8400942016 1.28492929317 -8.03803981813 -42.8400942016 1.28492929317 -8.03903981813 -42.8400942016 1.28492929317 -8.04003981813 -42.8400942016 1.28492929317 -8.04103981813 -42.8400942016 1.28492929317 -8.04203981813 -42.8400942016 1.28492929317 -8.04303981813 -42.8400942016 1.28492929317 -8.04403981813 -42.8400942016 1.28492929317 -8.04503981813 -42.8400942016 1.28492929317 -8.04603981813 -42.8400942016 1.28492929317 -8.04703981813 -42.8400942016 1.28492929317 -8.04803981813 -42.8400942016 1.28492929317 -8.04903981813 -42.8400942016 1.28492929317 -8.05003981813 -42.8400942016 1.28492929317 -8.05103981813 -42.8400942016 1.28492929317 -8.05203981813 -42.8400942016 1.28492929317 -8.05303981813 -42.8400942016 1.28492929317 -8.05403981813 -42.8400942016 1.28492929317 -8.05503981813 -42.8400942016 1.28492929317 -8.05603981813 -42.8400942016 1.28492929317 -8.05703981813 -42.8400942016 1.28492929317 -8.05803981813 -42.8400942016 1.28492929317 -8.05903981813 -42.8400942016 1.28492929317 -8.06003981813 -42.8400942016 1.28492929317 -8.06103981813 -42.8400942016 1.28492929317 -8.06203981813 -42.8400942016 1.28492929317 -8.06303981813 -42.8400942016 1.28492929317 -8.06403981813 -42.8400942016 1.28492929317 -8.06503981813 -42.8400942016 1.28492929317 -8.06603981813 -42.8400942016 1.28492929317 -8.06703981813 -42.8400942016 1.28492929317 -8.06803981813 -42.8400942016 1.28492929317 -8.06903981813 -42.8400942016 1.28492929317 -8.07003981813 -42.8400942016 1.28492929317 -8.07103981813 -42.8400942016 1.28492929317 -8.07203981813 -42.8400942016 1.28492929317 -8.07303981813 -42.8400942016 1.28492929317 -8.07403981813 -42.8400942016 1.28492929317 -8.07503981813 -42.8400942016 1.28492929317 -8.07603981813 -42.8400942016 1.28492929317 -8.07703981813 -42.8400942016 1.28492929317 -8.07803981813 -42.8400942016 1.28492929317 -8.07903981813 -42.8400942016 1.28492929317 -8.08003981813 -42.8400942016 1.28492929317 -8.08103981813 -42.8400942016 1.28492929317 -8.08203981813 -42.8400942016 1.28492929317 -8.08303981813 -42.8400942016 1.28492929317 -8.08403981813 -42.8400942016 1.28492929317 -8.08503981813 -42.8400942016 1.28492929317 -8.08603981813 -42.8400942016 1.28492929317 -8.08703981813 -42.8400942016 1.28492929317 -8.08803981813 -42.8400942016 1.28492929317 -8.08903981813 -42.8400942016 1.28492929317 -8.09003981813 -42.8400942016 1.28492929317 -8.09103981813 -42.8400942016 1.28492929317 -8.09203981813 -42.8400942016 1.28492929317 -8.09303981813 -42.8400942016 1.28492929317 -8.09403981813 -42.8400942016 1.28492929317 -8.09503981813 -42.8400942016 1.28492929317 -8.09603981813 -42.8400942016 1.28492929317 -8.09703981813 -42.8400942016 1.28492929317 -8.09803981813 -42.8400942016 1.28492929317 -8.09903981813 -42.8400942016 1.28492929317 -8.10003981813 -42.8400942016 1.28492929317 -8.10103981813 -42.8400942016 1.28492929317 -8.10203981813 -42.8400942016 1.28492929317 -8.10303981813 -42.8400942016 1.28492929317 -8.10403981813 -42.8400942016 1.28492929317 -8.10503981813 -42.8400942016 1.28492929317 -8.10603981813 -42.8400942016 1.28492929317 -8.10703981813 -42.8400942016 1.28492929317 -8.10803981813 -42.8400942016 1.28492929317 -8.10903981813 -42.8400942016 1.28492929317 -8.11003981813 -42.8400942016 1.28492929317 -8.11103981813 -42.8400942016 1.28492929317 -8.11203981813 -42.8400942016 1.28492929317 -8.11303981813 -42.8400942016 1.28492929317 -8.11403981813 -42.8400942016 1.28492929317 -8.11503981813 -42.8400942016 1.28492929317 -8.11603981813 -42.8400942016 1.28492929317 -8.11703981813 -42.8400942016 1.28492929317 -8.11803981813 -42.8400942016 1.28492929317 -8.11903981813 -42.8400942016 1.28492929317 -8.12003981813 -42.8400942016 1.28492929317 -8.12103981813 -42.8400942016 1.28492929317 -8.12203981813 -42.8400942016 1.28492929317 -8.12303981813 -42.8400942016 1.28492929317 -8.12403981813 -42.8400942016 1.28492929317 -8.12503981813 -42.8400942016 1.28492929317 -8.12603981813 -42.8400942016 1.28492929317 -8.12703981813 -42.8400942016 1.28492929317 -8.12803981813 -42.8400942016 1.28492929317 -8.12903981813 -42.8400942016 1.28492929317 -8.13003981813 -42.8400942016 1.28492929317 -8.13103981813 -42.8400942016 1.28492929317 -8.13203981813 -42.8400942016 1.28492929317 -8.13303981813 -42.8400942016 1.28492929317 -8.13403981813 -42.8400942016 1.28492929317 -8.13503981813 -42.8400942016 1.28492929317 -8.13603981813 -42.8400942016 1.28492929317 -8.13703981813 -42.8400942016 1.28492929317 -8.13803981813 -42.8400942016 1.28492929317 -8.13903981813 -42.8400942016 1.28492929317 -8.14003981813 -42.8400942016 1.28492929317 -8.14103981813 -42.8400942016 1.28492929317 -8.14203981813 -42.8400942016 1.28492929317 -8.14303981813 -42.8400942016 1.28492929317 -8.14403981813 -42.8400942016 1.28492929317 -8.14503981813 -42.8400942016 1.28492929317 -8.14603981813 -42.8400942016 1.28492929317 -8.14703981813 -42.8400942016 1.28492929317 -8.14803981813 -42.8400942016 1.28492929317 -8.14903981813 -42.8400942016 1.28492929317 -8.15003981813 -42.8400942016 1.28492929317 -8.15103981813 -42.8400942016 1.28492929317 -8.15203981813 -42.8400942016 1.28492929317 -8.15303981813 -42.8400942016 1.28492929317 -8.15403981813 -42.8400942016 1.28492929317 -8.15503981813 -42.8400942016 1.28492929317 -8.15603981813 -42.8400942016 1.28492929317 -8.15703981813 -42.8400942016 1.28492929317 -8.15803981813 -42.8400942016 1.28492929317 -8.15903981813 -42.8400942016 1.28492929317 -8.16003981813 -42.8400942016 1.28492929317 -8.16103981813 -42.8400942016 1.28492929317 -8.16203981813 -504.695656365 1.28492929317 -8.16303981813 -360.54929486 1.28492929317 -8.16403981813 -195.13922563 1.28492929317 -8.16503981813 -8.00245724874 1.28492929317 -8.16603981813 78.067343304 1.28492929317 -8.16703981813 -166.385011682 1.28492929317 -8.16803981813 -319.562454139 1.28492929317 -8.16903981813 -489.741912595 1.28492929317 -8.17003981813 -1080.0293031 1.28492929317 -8.17103981813 -1080.0293031 1.28492929317 -8.17203981813 -1080.0293031 1.28492929317 -8.17303981813 -1080.0293031 1.28492929317 -8.17403981813 -161.186597772 1.28492929317 -8.17503981813 -149.644693684 1.28492929317 -8.17603981813 -79.8722311173 1.28492929317 -8.17703981813 -45.7953006041 1.28492929317 -8.17803981813 -31.8012810136 1.28492929317 -8.17903981813 -120.647500505 1.28492929317 -8.18003981813 -58.7679156935 1.28492929317 -8.18103981813 -46.3370776683 1.28492929317 -8.18203981813 -36.5930302425 1.28492929317 -8.18303981813 -15.387522004 1.28492929317 -8.18403981813 40.2569980777 1.28492929317 -8.18503981813 72.9977441131 1.28492929317 -8.18603981813 86.5765527209 1.28492929317 -8.18703981813 107.62642199 1.28492929317 -8.18803981813 122.3863567 1.28492929317 -8.18903981813 235.096739005 1.28492929317 -8.19003981813 183.490059524 1.28492929317 -8.19103981813 125.667055634 1.28492929317 -8.19203981813 85.3280946049 1.28492929317 -8.19303981813 127.34202451 1.28492929317 -8.19403981813 221.790991577 1.28492929317 -8.19503981813 276.234303573 1.28492929317 -8.19603981813 380.555807555 1.28492929317 -8.19703981813 407.727273331 1.28492929317 -8.19803981813 425.880229782 1.28492929317 -8.19903981813 473.066189557 1.28492929317 -8.20003981813 502.469263778 1.28492929317 -8.20103981813 531.327761357 1.28492929317 -8.20203981813 476.553086309 1.28492929317 -8.20303981813 470.629820685 1.28492929317 -8.20403981813 369.227833126 1.28492929317 -8.20503981813 309.197465609 1.28492929317 -8.20603981813 313.494954541 1.28492929317 -8.20703981813 273.334192493 1.28492929317 -8.20803981813 426.007670374 1.28492929317 -8.20903981813 529.854363321 1.28492929317 -8.21003981813 619.454477094 1.28492929317 -8.21103981813 661.312245674 1.28492929317 -8.21203981813 737.481006677 1.28492929317 -8.21303981813 747.063442701 1.28492929317 -8.21403981813 752.576465658 1.28492929317 -8.21503981813 799.424341193 1.28492929317 -8.21603981813 843.490055806 1.28492929317 -8.21703981813 859.066475458 1.28492929317 -8.21803981813 872.827997221 1.28492929317 -8.21903981813 852.33109064 1.28492929317 -8.22003981813 839.114092344 1.28492929317 -8.22103981813 844.407843413 1.28492929317 -8.22203981813 875.109591933 1.28492929317 -8.22303981813 887.087267781 1.28492929317 -8.22403981813 888.666007281 1.28492929317 -8.22503981813 868.751991625 1.28492929317 -8.22603981813 859.678748223 1.28492929317 -8.22703981813 845.392186592 1.28492929317 -8.22803981813 828.113696631 1.28492929317 -8.22903981813 790.059028659 1.28492929317 -8.23003981813 752.641209826 1.28492929317 -8.23103981813 714.737984696 1.28492929317 -8.23203981813 691.658424544 1.28492929317 -8.23303981813 780.421348265 1.28492929317 -8.23403981813 795.578615829 1.28492929317 -8.23503981813 805.182504004 1.28492929317 -8.23603981813 836.606181296 1.28492929317 -8.23703981813 853.030587164 1.28492929317 -8.23803981813 859.794851005 1.28492929317 -8.23903981813 841.352756293 1.28492929317 -8.24003981813 821.538484875 1.28492929317 -8.24103981813 760.081374079 1.28492929317 -8.24203981813 700.041246798 1.28492929317 -8.24303981813 627.997758849 1.28492929317 -8.24403981813 559.44828493 1.28492929317 -8.24503981813 482.452458499 1.28492929317 -8.24603981813 410.055707317 1.28492929317 -8.24703981813 347.810427004 1.28492929317 -8.24803981813 294.10968615 1.28492929317 -8.24903981813 252.4376289 1.28492929317 -8.25003981813 218.888388275 1.28492929317 -8.25103981813 196.650154146 1.28492929317 -8.25203981813 179.351036356 1.28492929317 -8.25303981813 177.494980164 1.28492929317 -8.25403981813 176.304566577 1.28492929317 -8.25503981813 198.315142607 1.28492929317 -8.25603981813 211.727590441 1.28492929317 -8.25703981813 250.295394475 1.28492929317 -8.25803981813 275.916840551 1.28492929317 -8.25903981813 305.457828133 1.28492929317 -8.26003981813 331.853623775 1.28492929317 -8.26103981813 365.574931003 1.28492929317 -8.26203981813 398.579555235 1.28492929317 -8.26303981813 421.125888196 1.28492929317 -8.26403981813 432.894578831 1.28492929317 -8.26503981813 443.751137861 1.28492929317 -8.26603981813 450.234680989 1.28492929317 -8.26703981813 461.223244763 1.28492929317 -8.26803981813 464.6947195 1.28492929317 -8.26903981813 465.244321276 1.28492929317 -8.27003981813 461.091567314 1.28492929317 -8.27103981813 457.523803962 1.28492929317 -8.27203981813 447.301543889 1.28492929317 -8.27303981813 434.007237151 1.28492929317 -8.27403981813 419.311619997 1.28492929317 -8.27503981813 404.509344561 1.28492929317 -8.27603981813 393.259567226 1.28492929317 -8.27703981813 387.660076464 1.28492929317 -8.27803981813 386.51515831 1.28492929317 -8.27903981813 380.247084141 1.28492929317 -8.28003981813 371.639258946 1.28492929317 -8.28103981813 366.289665369 1.28492929317 -8.28203981813 361.998607543 1.28492929317 -8.28303981813 359.503211237 1.28492929317 -8.28403981813 357.043531778 1.28492929317 -8.28503981813 359.394243508 1.28492929317 -8.28603981813 358.264726851 1.28492929317 -8.28703981813 358.7050948 1.28492929317 -8.28803981813 358.205704375 1.28492929317 -8.28903981813 362.19173932 1.28492929317 -8.29003981813 360.629881375 1.28492929317 -8.29103981813 363.490847775 1.28492929317 -8.29203981813 366.110649915 1.28492929317 -8.29303981813 373.271483507 1.28492929317 -8.29403981813 380.38685078 1.28492929317 -8.29503981813 391.700104857 1.28492929317 -8.29603981813 396.254637935 1.28492929317 -8.29703981813 398.882067686 1.28492929317 -8.29803981813 422.82344165 1.28492929317 -8.29903981813 424.918542262 1.28492929317 -8.30003981813 417.36183973 1.28492929317 -8.30103981813 410.645920068 1.28492929317 -8.30203981813 410.510761889 1.28492929317 -8.30303981813 417.069757324 1.28492929317 -8.30403981813 404.943524204 1.28492929317 -8.30503981813 403.995957743 1.28492929317 -8.30603981813 396.649116589 1.28492929317 -8.30703981813 407.334165006 1.28492929317 -8.30803981813 417.752716024 1.28492929317 -8.30903981813 425.291325828 1.28492929317 -8.31003981813 426.16163037 1.28492929317 -8.31103981813 425.988815513 1.28492929317 -8.31203981813 414.287443783 1.28492929317 -8.31303981813 396.834963438 1.28492929317 -8.31403981813 383.144324072 1.28492929317 -8.31503981813 373.595235881 1.28492929317 -8.31603981813 369.787287077 1.28492929317 -8.31703981813 356.475533388 1.28492929317 -8.31803981813 348.452632316 1.28492929317 -8.31903981813 346.870117505 1.28492929317 -8.32003981813 347.063325529 1.28492929317 -8.32103981813 352.056969635 1.28492929317 -8.32203981813 353.680852441 1.28492929317 -8.32303981813 357.411681979 1.28492929317 -8.32403981813 357.528628694 1.28492929317 -8.32503981813 347.770640099 1.28492929317 -8.32603981813 355.705597729 1.28492929317 -8.32703981813 350.176250382 1.28492929317 -8.32803981813 344.514415267 1.28492929317 -8.32903981813 343.757230304 1.28492929317 -8.33003981813 345.94606744 1.28492929317 -8.33103981813 344.77148738 1.28492929317 -8.33203981813 343.32235951 1.28492929317 -8.33303981813 340.493728025 1.28492929317 -8.33403981813 339.798786027 1.28492929317 -8.33503981813 336.476800216 1.28492929317 -8.33603981813 327.409851492 1.28492929317 -8.33703981813 322.051724279 1.28492929317 -8.33803981813 318.453762305 1.28492929317 -8.33903981813 313.226846651 1.28492929317 -8.34003981813 315.08210347 1.28492929317 -8.34103981813 302.582978481 1.28492929317 -8.34203981813 301.267064079 1.28492929317 -8.34303981813 290.726733856 1.28492929317 -8.34403981813 287.626032549 1.28492929317 -8.34503981813 286.585005485 1.28492929317 -8.34603981813 286.269047952 1.28492929317 -8.34703981813 286.824111188 1.28492929317 -8.34803981813 285.896658069 1.28492929317 -8.34903981813 284.790226721 1.28492929317 -8.35003981813 285.874898971 1.28492929317 -8.35103981813 286.293639266 1.28492929317 -8.35203981813 282.119778489 1.28492929317 -8.35303981813 282.726474611 1.28492929317 -8.35403981813 283.505414203 1.28492929317 -8.35503981813 281.19989509 1.28492929317 -8.35603981813 276.923130223 1.28492929317 -8.35703981813 274.937949151 1.28492929317 -8.35803981813 271.141133555 1.28492929317 -8.35903981813 269.724553297 1.28492929317 -8.36003981813 266.158655875 1.90245337252 -8.36103981813 262.554797967 2.86890928699 -8.36203981813 261.189316383 2.51696937207 -8.36303981813 258.625644751 2.51696937207 -8.36403981813 254.015130829 2.15040959616 -8.36503981813 252.667092532 2.71022838446 -8.36603981813 245.984804364 2.34327715667 -8.36703981813 240.682585595 1.81807626303 -8.36803981813 242.675898362 1.81807626303 -8.36903981813 241.229095032 1.81807626303 -8.37003981813 238.216387446 1.81807626303 -8.37103981813 242.065198704 1.81807626303 -8.37203981813 239.211361569 1.81807626303 -8.37303981813 238.373098452 1.81807626303 -8.37403981813 238.517531505 1.81807626303 -8.37503981813 238.363031248 1.81807626303 -8.37603981813 238.726288939 1.81807626303 -8.37703981813 238.158847063 1.81807626303 -8.37803981813 238.054713133 1.81807626303 -8.37903981813 235.220545299 1.81807626303 -8.38003981813 234.435954271 1.81807626303 -8.38103981813 231.536469799 1.81807626303 -8.38203981813 230.397463329 1.81807626303 -8.38303981813 227.533987857 1.81807626303 -8.38403981813 225.329304659 1.81807626303 -8.38503981813 224.938228227 1.81807626303 -8.38603981813 223.784002417 1.81807626303 -8.38703981813 222.6609028 1.81807626303 -8.38803981813 221.85735698 1.81807626303 -8.38903981813 214.769211943 1.81807626303 -8.39003981813 216.846654535 1.81807626303 -8.39103981813 220.26335702 1.81807626303 -8.39203981813 222.23819709 1.81807626303 -8.39303981813 222.306831633 1.81807626303 -8.39403981813 222.802059111 1.81807626303 -8.39503981813 221.950916378 1.81807626303 -8.39603981813 220.796332111 1.81807626303 -8.39703981813 219.311142549 1.81807626303 -8.39803981813 219.493455245 1.81807626303 -8.39903981813 217.305349634 1.81807626303 -8.40003981813 217.186791373 1.81807626303 -8.40103981813 218.213373127 1.81807626303 -8.40203981813 218.364153203 1.81807626303 -8.40303981813 218.6512392 1.81807626303 -8.40403981813 219.300357215 1.81807626303 -8.40503981813 220.139241541 1.81807626303 -8.40603981813 219.160286405 1.81807626303 -8.40703981813 219.410790741 1.81807626303 -8.40803981813 216.044246139 1.81807626303 -8.40903981813 215.171225381 1.81807626303 -8.41003981813 215.033327436 1.81807626303 -8.41103981813 214.488029941 1.81807626303 -8.41203981813 217.92290894 1.81807626303 -8.41303981813 218.422336298 1.81807626303 -8.41403981813 220.554482135 1.81807626303 -8.41503981813 219.959332171 1.81807626303 -8.41603981813 219.700666092 1.81807626303 -8.41703981813 219.205927026 1.81807626303 -8.41803981813 218.700879943 1.81807626303 -8.41903981813 218.635639517 1.81807626303 -8.42003981813 223.871544761 1.81807626303 -8.42103981813 221.565813935 1.81807626303 -8.42203981813 230.307864173 1.81807626303 -8.42303981813 231.028736498 1.81807626303 -8.42403981813 231.361653395 1.81807626303 -8.42503981813 234.206145973 1.81807626303 -8.42603981813 235.376823222 1.81807626303 -8.42703981813 234.226651196 1.81807626303 -8.42803981813 240.968477348 1.81807626303 -8.42903981813 241.263896173 1.81807626303 -8.43003981813 241.276018447 1.81807626303 -8.43103981813 239.490913946 1.81807626303 -8.43203981813 237.555926805 1.81807626303 -8.43303981813 235.805693597 1.81807626303 -8.43403981813 235.388603885 1.81807626303 -8.43503981813 246.116928155 1.81807626303 -8.43603981813 240.936066888 1.81807626303 -8.43703981813 242.188476464 1.81807626303 -8.43803981813 251.399308791 1.81807626303 -8.43903981813 258.416634299 1.81807626303 -8.44003981813 264.685481479 1.81807626303 -8.44103981813 257.213650868 1.81807626303 -8.44203981813 250.535977993 1.81807626303 -8.44303981813 256.926206952 1.81807626303 -8.44403981813 273.383189479 1.81807626303 -8.44503981813 280.404341246 1.81807626303 -8.44603981813 319.724710367 1.81807626303 -8.44703981813 319.95722468 1.81807626303 -8.44803981813 320.152170075 1.81807626303 -8.44903981813 317.081886904 1.81807626303 -8.45003981813 329.108759457 1.81807626303 -8.45103981813 336.78296217 1.81807626303 -8.45203981813 343.347684793 1.81807626303 -8.45303981813 346.342942159 1.81807626303 -8.45403981813 365.437381343 1.81807626303 -8.45503981813 413.746021119 1.81807626303 -8.45603981813 425.511954017 1.81807626303 -8.45703981813 442.822887787 1.81807626303 -8.45803981813 464.87343423 1.81807626303 -8.45903981813 474.91960963 1.81807626303 -8.46003981813 529.272000432 1.81807626303 -8.46103981813 539.567079605 1.81807626303 -8.46203981813 529.790055863 1.81807626303 -8.46303981813 588.59279803 1.81807626303 -8.46403981813 584.630387031 1.81807626303 -8.46503981813 614.627477761 1.81807626303 -8.46603981813 667.300982906 1.81807626303 -8.46703981813 674.208462731 1.81807626303 -8.46803981813 664.987943117 1.81807626303 -8.46903981813 597.350116432 1.81807626303 -8.47003981813 556.248929516 1.81807626303 -8.47103981813 503.997807096 1.81807626303 -8.47203981813 471.916762009 1.81807626303 -8.47303981813 450.593903415 1.81807626303 -8.47403981813 404.411165696 1.81807626303 -8.47503981813 369.706003028 1.81807626303 -8.47603981813 368.203781331 1.81807626303 -8.47703981813 383.325102713 1.81807626303 -8.47803981813 373.690805552 1.81807626303 -8.47903981813 362.389559247 1.81807626303 -8.48003981813 356.997127813 1.81807626303 -8.48103981813 362.764039106 1.81807626303 -8.48203981813 375.013483448 1.81807626303 -8.48303981813 408.296510655 1.81807626303 -8.48403981813 449.670340009 1.81807626303 -8.48503981813 496.087018329 1.81807626303 -8.48603981813 465.597666372 1.81807626303 -8.48703981813 491.903545255 1.81807626303 -8.48803981813 498.650368731 1.81807626303 -8.48903981813 503.536570759 1.81807626303 -8.49003981813 512.930839188 1.81807626303 -8.49103981813 518.409525418 1.81807626303 -8.49203981813 513.466157488 1.81807626303 -8.49303981813 567.517976304 1.81807626303 -8.49403981813 546.124090351 1.81807626303 -8.49503981813 538.766521248 1.81807626303 -8.49603981813 522.805676781 1.81807626303 -8.49703981813 511.892828463 1.81807626303 -8.49803981813 494.112857883 1.81807626303 -8.49903981813 493.756253484 0.649441328863 -8.50003981813 470.393229946 -1.4008929111 -8.50103981813 465.857774851 -0.165369479416 -8.50203981813 478.724353819 0.42881965328 -8.50303981813 451.785578175 0.42881965328 -8.50403981813 444.071465626 1.0440483026 -8.50503981813 438.685104411 -1.20436268722 -8.50603981813 438.16465243 -0.814437573928 -8.50703981813 449.864034434 -0.0438377387161 -8.50803981813 424.293314664 -0.0438377387161 -8.50903981813 427.400571559 -0.0438377387161 -8.51003981813 444.241534333 -0.0438377387161 -8.51103981813 460.782297806 -0.0438377387161 -8.51203981813 428.28804028 -0.0438377387161 -8.51303981813 451.331379486 -0.0438377387161 -8.51403981813 523.856619609 -0.0438377387161 -8.51503981813 460.394058141 -0.0438377387161 -8.51603981813 485.204412292 -0.0438377387161 -8.51703981813 496.992189852 -0.0438377387161 -8.51803981813 474.494209167 -0.0438377387161 -8.51903981813 474.484694621 -0.0438377387161 -8.52003981813 466.268724287 -0.0438377387161 -8.52103981813 474.624214733 -0.0438377387161 -8.52203981813 473.452549057 -0.0438377387161 -8.52303981813 475.235020828 -0.0438377387161 -8.52403981813 474.181084419 -0.0438377387161 -8.52503981813 463.661665305 -0.0438377387161 -8.52603981813 458.793326861 -0.0438377387161 -8.52703981813 428.199223594 -0.0438377387161 -8.52803981813 428.662829104 -0.0438377387161 -8.52903981813 457.510840558 -0.0438377387161 -8.53003981813 471.689930525 -0.0438377387161 -8.53103981813 431.636853941 -0.0438377387161 -8.53203981813 411.587974218 -0.0438377387161 -8.53303981813 426.809380149 -0.0438377387161 -8.53403981813 395.996547992 -0.0438377387161 -8.53503981813 396.518965927 -0.0438377387161 -8.53603981813 443.15992905 -0.0438377387161 -8.53703981813 370.139116695 -0.0438377387161 -8.53803981813 375.859596319 -0.0438377387161 -8.53903981813 370.752354586 -0.0438377387161 -8.54003981813 373.405450841 -0.0438377387161 -8.54103981813 346.394603535 -0.0438377387161 -8.54203981813 347.028231711 -0.0438377387161 -8.54303981813 345.902765215 -0.0438377387161 -8.54403981813 341.859116042 -0.0438377387161 -8.54503981813 326.741598779 -0.0438377387161 -8.54603981813 321.852808225 -0.0438377387161 -8.54703981813 306.349019245 -0.0438377387161 -8.54803981813 308.312690744 -0.0438377387161 -8.54903981813 294.697721228 -0.0438377387161 -8.55003981813 295.792541763 -0.0438377387161 -8.55103981813 289.920155514 -0.0438377387161 -8.55203981813 295.50989762 -0.0438377387161 -8.55303981813 278.534693051 -0.0438377387161 -8.55403981813 286.727212083 -0.0438377387161 -8.55503981813 276.930305837 -0.0438377387161 -8.55603981813 273.893071778 -0.0438377387161 -8.55703981813 277.276783096 -0.0438377387161 -8.55803981813 269.728832846 -0.0438377387161 -8.55903981813 270.017733283 -0.0438377387161 -8.56003981813 269.89636309 -0.0438377387161 -8.56103981813 269.547236088 -0.0438377387161 -8.56203981813 264.143516871 -0.0438377387161 -8.56303981813 263.201918798 -0.0438377387161 -8.56403981813 261.341183457 -0.0438377387161 -8.56503981813 259.639757541 -0.0438377387161 -8.56603981813 257.04733653 -0.0438377387161 -8.56703981813 254.784491645 -0.0438377387161 -8.56803981813 253.996726394 -0.0438377387161 -8.56903981813 249.484188599 -0.0438377387161 -8.57003981813 252.526318173 -0.0438377387161 -8.57103981813 241.981396148 -0.0438377387161 -8.57203981813 239.231811013 -0.0438377387161 -8.57303981813 235.466899049 -0.0438377387161 -8.57403981813 234.005448588 -0.0438377387161 -8.57503981813 233.489374979 -0.0438377387161 -8.57603981813 235.662858076 -0.0438377387161 -8.57703981813 225.480324923 -0.0438377387161 -8.57803981813 227.32888225 -0.0438377387161 -8.57903981813 226.263689569 -0.0438377387161 -8.58003981813 224.462022521 -0.0438377387161 -8.58103981813 219.181248225 -0.0438377387161 -8.58203981813 216.914949472 -0.0438377387161 -8.58303981813 216.883096227 -0.0438377387161 -8.58403981813 213.395789299 -0.0438377387161 -8.58503981813 210.304333306 -0.0438377387161 -8.58603981813 207.854545734 -0.0438377387161 -8.58703981813 205.945005363 -0.0438377387161 -8.58803981813 204.472530585 -0.0438377387161 -8.58903981813 198.183964162 -0.0438377387161 -8.59003981813 199.176248693 -0.0438377387161 -8.59103981813 193.95812391 -0.0438377387161 -8.59203981813 193.590708559 -0.0438377387161 -8.59303981813 194.286403636 -0.0438377387161 -8.59403981813 191.505995463 -0.0438377387161 -8.59503981813 188.45625883 -0.0438377387161 -8.59603981813 186.974108902 -0.0438377387161 -8.59703981813 184.626303966 -0.0438377387161 -8.59803981813 181.79953233 -0.0438377387161 -8.59903981813 180.767944654 -0.0438377387161 -8.60003981813 179.137662207 -0.0438377387161 -8.60103981813 176.620067618 -0.0438377387161 -8.60203981813 176.014684717 -0.0438377387161 -8.60303981813 172.723867008 -0.0438377387161 -8.60403981813 173.087425605 -0.0438377387161 -8.60503981813 167.610332576 -0.0438377387161 -8.60603981813 165.228427333 -0.0438377387161 -8.60703981813 165.354518934 -0.0438377387161 -8.60803981813 164.005910621 -0.0438377387161 -8.60903981813 161.570436117 -0.0438377387161 -8.61003981813 157.505868471 -0.0438377387161 -8.61103981813 157.272169942 -0.0438377387161 -8.61203981813 152.15734054 -0.0438377387161 -8.61303981813 153.297070433 -0.0438377387161 -8.61403981813 153.047858706 -0.0438377387161 -8.61503981813 146.250884946 -0.0438377387161 -8.61603981813 149.656989337 -0.0438377387161 -8.61703981813 149.549468316 -0.0438377387161 -8.61803981813 145.547144648 -0.0438377387161 -8.61903981813 145.421024332 -0.0438377387161 -8.62003981813 144.546671244 -0.0438377387161 -8.62103981813 143.364902089 -0.0438377387161 -8.62203981813 157.793343078 -0.0438377387161 -8.62303981813 155.91205091 -0.0438377387161 -8.62403981813 150.709134216 -0.0438377387161 -8.62503981813 145.169528049 -0.0438377387161 -8.62603981813 143.32114916 -0.0438377387161 -8.62703981813 133.857560794 -0.0438377387161 -8.62803981813 138.146802896 -0.0438377387161 -8.62903981813 137.994949686 -0.0438377387161 -8.63003981813 130.444360297 -0.0438377387161 -8.63103981813 126.233478097 -0.0438377387161 -8.63203981813 118.490862908 -0.0438377387161 -8.63303981813 120.919692867 -0.0438377387161 -8.63403981813 123.394178137 -0.0438377387161 -8.63503981813 121.947844105 -0.0438377387161 -8.63603981813 108.816466975 -0.0438377387161 -8.63703981813 117.745708564 -0.0438377387161 -8.63803981813 101.07362798 -0.0438377387161 -8.63903981813 99.5351473423 -0.0438377387161 -8.64003981813 88.8214066305 -0.0438377387161 -8.64103981813 92.2068113428 -0.0438377387161 -8.64203981813 85.899285591 -0.0438377387161 -8.64303981813 84.3730995458 -0.0438377387161 -8.64403981813 74.8035390315 -0.0438377387161 -8.64503981813 68.5649243559 -0.0438377387161 -8.64603981813 67.6614963617 -0.0438377387161 -8.64703981813 51.9262362634 -0.0438377387161 -8.64803981813 50.7558756099 -0.0438377387161 -8.64903981813 51.5801155484 -0.0438377387161 -8.65003981813 41.9772516701 -0.0438377387161 -8.65103981813 43.9299890927 -0.0438377387161 -8.65203981813 34.047088068 -0.0438377387161 -8.65303981813 36.2476523054 -0.0438377387161 -8.65403981813 20.0079984698 -0.0438377387161 -8.65503981813 28.4846775162 -0.0438377387161 -8.65603981813 25.9649176487 -0.0438377387161 -8.65703981813 18.1866578668 -0.0438377387161 -8.65803981813 21.6072886526 -0.0438377387161 -8.65903981813 54.3850776418 -0.0438377387161 -8.66003981813 33.8713066824 -0.0438377387161 -8.66103981813 14.9510602184 -0.0438377387161 -8.66203981813 48.1610369198 -0.0438377387161 -8.66303981813 3.3808827285 -0.0438377387161 -8.66403981813 100.863353616 -0.0438377387161 -8.66503981813 356.92105909 -0.0438377387161 -8.66603981813 495.095379899 -0.0438377387161 -8.66703981813 525.885106071 -0.0438377387161 -8.66803981813 444.120586058 -0.0438377387161 -8.66903981813 365.68336515 -0.0438377387161 -8.67003981813 260.472195932 -0.0438377387161 -8.67103981813 157.067147968 -0.0438377387161 -8.67203981813 93.8723889956 -0.0438377387161 -8.67303981813 50.835917562 -0.0438377387161 -8.67403981813 -10.3846072288 -0.0438377387161 -8.67503981813 -33.9713808791 -0.0438377387161 -8.67603981813 -47.3902986451 -0.0438377387161 -8.67703981813 -39.6069219531 -0.0438377387161 -8.67803981813 -44.7181664636 -0.0438377387161 -8.67903981813 -61.3163453144 -0.0438377387161 -8.68003981813 -80.5775637492 -0.0438377387161 -8.68103981813 -80.5775637492 -0.0438377387161 -8.68203981813 -80.5775637492 -0.0438377387161 -8.68303981813 -80.5775637492 -0.0438377387161 -8.68403981813 -80.5775637492 -0.0438377387161 -8.68503981813 -80.5775637492 -0.0438377387161 -8.68603981813 -80.5775637492 -0.0438377387161 -8.68703981813 -80.5775637492 -0.0438377387161 -8.68803981813 -80.5775637492 -0.0438377387161 -8.68903981813 -80.5775637492 -0.0438377387161 -8.69003981813 -80.5775637492 -0.0438377387161 -8.69103981813 -80.5775637492 -0.0438377387161 -8.69203981813 -80.5775637492 -0.0438377387161 -8.69303981813 -80.5775637492 -0.0438377387161 -8.69403981813 -80.5775637492 -0.0438377387161 -8.69503981813 -80.5775637492 -0.0438377387161 -8.69603981813 -80.5775637492 -0.0438377387161 -8.69703981813 -80.5775637492 -0.0438377387161 -8.69803981813 -80.5775637492 -0.0438377387161 -8.69903981813 -80.5775637492 -0.0438377387161 -8.70003981813 -80.5775637492 -0.0438377387161 -8.70103981813 -80.5775637492 -0.0438377387161 -8.70203981813 -80.5775637492 -0.0438377387161 -8.70303981813 -80.5775637492 -0.0438377387161 -8.70403981813 -80.5775637492 -0.0438377387161 -8.70503981813 64.077835916 -0.0438377387161 -8.70603981813 66.7784119171 -0.0438377387161 -8.70703981813 67.0098381876 -0.0438377387161 -8.70803981813 117.745722891 -0.0438377387161 -8.70903981813 127.003350853 -0.0438377387161 -8.71003981813 124.322144681 -0.0438377387161 -8.71103981813 124.811618903 -0.0438377387161 -8.71203981813 128.726333647 -0.0438377387161 -8.71303981813 130.51241951 -0.0438377387161 -8.71403981813 127.718066958 -0.0438377387161 -8.71503981813 144.285900934 -0.0438377387161 -8.71603981813 260.321427061 -0.0438377387161 -8.71703981813 207.084082281 -0.0438377387161 -8.71803981813 211.265349661 -0.0438377387161 -8.71903981813 208.662115755 -0.0438377387161 -8.72003981813 203.767211963 -0.0438377387161 -8.72103981813 195.057738794 -0.0438377387161 -8.72203981813 197.082061964 -0.0438377387161 -8.72303981813 187.465722835 -0.0438377387161 -8.72403981813 182.292102994 -0.0438377387161 -8.72503981813 161.438552275 -0.0438377387161 -8.72603981813 164.14881886 -0.0438377387161 -8.72703981813 146.134331983 -0.0438377387161 -8.72803981813 183.595014259 -0.0438377387161 -8.72903981813 231.061064908 -0.0438377387161 -8.73003981813 198.470870708 -0.0438377387161 -8.73103981813 203.71058971 -0.0438377387161 -8.73203981813 136.656266423 -0.0438377387161 -8.73303981813 117.49879435 -0.0438377387161 -8.73403981813 113.542783435 -0.0438377387161 -8.73503981813 72.5736218071 -0.0438377387161 -8.73603981813 45.9031503295 -0.0438377387161 -8.73703981813 28.8842574826 -0.0438377387161 -8.73803981813 34.6811522309 -0.0438377387161 -8.73903981813 25.0080580002 -0.0438377387161 -8.74003981813 28.4361607038 -0.0438377387161 -8.74103981813 8.8350849691 -0.0438377387161 -8.74203981813 19.9440272433 -0.0438377387161 -8.74303981813 23.3492311414 -0.0438377387161 -8.74403981813 12.1319223668 -0.0438377387161 -8.74503981813 10.7673929086 -0.0438377387161 -8.74603981813 14.7595395244 -0.0438377387161 -8.74703981813 14.7236889114 -0.0438377387161 -8.74803981813 13.5989170553 -0.0438377387161 -8.74903981813 16.2107892714 -0.0438377387161 -8.75003981813 15.4584225422 -0.0438377387161 -8.75103981813 15.4804216133 -0.0438377387161 -8.75203981813 12.5848463779 -0.0438377387161 -8.75303981813 15.0381554049 -0.0438377387161 -8.75403981813 16.3531940099 -0.0438377387161 -8.75503981813 -0.0142805623123 -0.0438377387161 -8.75603981813 -1.42776162166 -0.0438377387161 -8.75703981813 -4.85692510913 -0.0438377387161 -8.75803981813 -3.37897378893 -0.0438377387161 -8.75903981813 16.6073072692 -0.0438377387161 -8.76003981813 8.99163900348 -0.0438377387161 -8.76103981813 7.22651028028 -0.0438377387161 -8.76203981813 2.85867806332 -0.0438377387161 -8.76303981813 -3.80685635129 -0.0438377387161 -8.76403981813 12.7417921916 -0.0438377387161 -8.76503981813 46.179545123 -0.0438377387161 -8.76603981813 70.0186936322 -0.0438377387161 -8.76703981813 69.7071726119 -0.0438377387161 -8.76803981813 60.7276623047 -0.0438377387161 -8.76903981813 35.3842213517 -0.0438377387161 -8.77003981813 18.4479797896 -0.0438377387161 -8.77103981813 7.41392815138 -0.0438377387161 -8.77203981813 0.105085508117 -0.0438377387161 -8.77303981813 -2.39126685699 -0.0438377387161 -8.77403981813 -5.29136001191 -0.0438377387161 -8.77503981813 -1.20350962854 -0.0438377387161 -8.77603981813 1.71704226175 -0.0438377387161 -8.77703981813 -4.38259880029 -0.0438377387161 -8.77803981813 -5.02663117279 -0.0438377387161 -8.77903981813 -4.78988707096 -0.0438377387161 -8.78003981813 -2.87717917747 -0.0438377387161 -8.78103981813 0.427592879484 -0.0438377387161 -8.78203981813 1.23270443045 -0.0438377387161 -8.78303981813 2.85832690988 -0.0438377387161 -8.78403981813 1.21330727269 -0.0438377387161 -8.78503981813 0.770519658176 -0.0438377387161 -8.78603981813 -2.61723914504 -0.0438377387161 -8.78703981813 13.9071789811 -0.0438377387161 -8.78803981813 10.9831614227 -0.0438377387161 -8.78903981813 3.19163225426 -0.0438377387161 -8.79003981813 -5.16952894297 -0.0438377387161 -8.79103981813 6.58902969253 -0.0438377387161 -8.79203981813 11.0836447551 -0.0438377387161 -8.79303981813 12.1049483162 -0.0438377387161 -8.79403981813 11.2800152386 -0.0438377387161 -8.79503981813 9.94320458346 -0.0438377387161 -8.79603981813 8.97761644059 -0.0438377387161 -8.79703981813 8.38945175419 -0.0438377387161 -8.79803981813 7.87004723959 -0.0438377387161 -8.79903981813 7.53278952878 -0.0438377387161 -8.80003981813 7.27190964185 -0.0438377387161 -8.80103981813 6.88834635937 -0.0438377387161 -8.80203981813 6.34448306277 -0.0438377387161 -8.80303981813 6.4668106979 -0.0438377387161 -8.80403981813 6.2983372858 -0.0438377387161 -8.80503981813 8.74591222518 -0.0438377387161 -8.80603981813 8.48298908738 -0.0438377387161 -8.80703981813 8.98932410264 -0.0438377387161 -8.80803981813 7.75983496234 -0.0438377387161 -8.80903981813 8.76939575882 -0.0438377387161 -8.81003981813 8.21629666512 -0.0438377387161 -8.81103981813 6.30744844363 -0.0438377387161 -8.81203981813 -1.17188768275 -0.0438377387161 -8.81303981813 0.658953024165 -0.0438377387161 -8.81403981813 3.17853200902 -0.0438377387161 -8.81503981813 1.639643672 -0.0438377387161 -8.81603981813 -2.65765112445 -0.0438377387161 -8.81703981813 -3.38250553627 -0.0438377387161 -8.81803981813 -3.90703722557 -0.0438377387161 -8.81903981813 -4.08945202754 -0.0438377387161 -8.82003981813 -4.73836498297 -0.0438377387161 -8.82103981813 -8.38482301667 -0.0438377387161 -8.82203981813 -7.85198500421 -0.0438377387161 -8.82303981813 -4.81496148592 -0.0438377387161 -8.82403981813 -8.2641864231 -0.0438377387161 -8.82503981813 -7.6968136559 -0.0438377387161 -8.82603981813 -7.88511341906 -0.0438377387161 -8.82703981813 -6.53465146396 -0.0438377387161 -8.82803981813 -7.32903305375 -0.0438377387161 -8.82903981813 -7.46819782107 -0.0438377387161 -8.83003981813 -6.70471039356 -0.0438377387161 -8.83103981813 -7.34010447643 -0.0438377387161 -8.83203981813 -7.08683756879 -0.0438377387161 -8.83303981813 -6.78509979264 -0.0438377387161 -8.83403981813 -8.09219736708 -2.61348299837 -8.83503981813 -9.14480354506 -2.54604095568 -8.83603981813 -9.90872725285 -2.54347010324 -8.83703981813 -3.99193121506 -2.59694742775 -8.83803981813 -4.09307941018 -2.52474602067 -8.83903981813 -6.05278542633 -2.52474602067 -8.84003981813 -7.39983191076 -2.52474602067 -8.84103981813 -8.9364066105 -2.52474602067 -8.84203981813 -9.80249622771 -2.52474602067 -8.84303981813 -15.2959116098 -2.52474602067 -8.84403981813 -16.9896025805 -2.52474602067 -8.84503981813 -17.6383896462 -2.52474602067 -8.84603981813 -17.4060690773 -2.52474602067 -8.84703981813 -17.7346608789 -2.52474602067 -8.84803981813 -18.497841658 -2.52474602067 -8.84903981813 -19.8786529012 -2.52474602067 -8.85003981813 -21.8021003737 -2.52474602067 -8.85103981813 -22.6512070829 -2.52474602067 -8.85203981813 -23.8526502521 -2.52474602067 -8.85303981813 -24.6708202849 -2.52474602067 -8.85403981813 -27.068139648 -2.52474602067 -8.85503981813 -26.213700224 -2.52474602067 -8.85603981813 -31.0680112634 -2.52474602067 -8.85703981813 -34.6481798499 -2.52474602067 -8.85803981813 -38.869053063 -2.52474602067 -8.85903981813 -37.7604899315 -2.52474602067 -8.86003981813 -42.2784479124 -2.52474602067 -8.86103981813 -37.7655202115 -2.52474602067 -8.86203981813 -26.745057041 -2.52474602067 -8.86303981813 -17.4655305934 -2.52474602067 -8.86403981813 -11.9844351347 -2.52474602067 -8.86503981813 -8.52913293253 -2.52474602067 -8.86603981813 -7.00273069309 -2.52474602067 -8.86703981813 -7.97599464291 -2.52474602067 -8.86803981813 -9.71957728989 -2.52474602067 -8.86903981813 -6.86165704754 -2.52474602067 -8.87003981813 -5.03656114789 -2.52474602067 -8.87103981813 -4.25825420524 -2.52474602067 -8.87203981813 -6.11287704256 -2.52474602067 -8.87303981813 -4.74629266212 -2.52474602067 -8.87403981813 -5.01956685926 -2.52474602067 -8.87503981813 -3.09777473385 -2.52474602067 -8.87603981813 -1.69921836791 -2.52474602067 -8.87703981813 -1.56943162624 -2.52474602067 -8.87803981813 -1.87686110969 -2.52474602067 -8.87903981813 -3.00986299472 -2.52474602067 -8.88003981813 -4.21253468557 -2.52474602067 -8.88103981813 -5.28307452385 -2.52474602067 -8.88203981813 -5.28307452385 -2.52474602067 -8.88303981813 -5.28307452385 -2.52474602067 -8.88403981813 -5.28307452385 -2.52474602067 -8.88503981813 -5.28307452385 -2.52474602067 -8.88603981813 -5.28307452385 -2.52474602067 -8.88703981813 -5.28307452385 -2.52474602067 -8.88803981813 -5.28307452385 -2.52474602067 -8.88903981813 -5.28307452385 -2.52474602067 -8.89003981813 -5.28307452385 -2.52474602067 -8.89103981813 -5.28307452385 -2.52474602067 -8.89203981813 -5.28307452385 -2.52474602067 -8.89303981813 -5.28307452385 -2.52474602067 -8.89403981813 -5.28307452385 -2.52474602067 -8.89503981813 -5.28307452385 -2.52474602067 -8.89603981813 -5.28307452385 -2.52474602067 -8.89703981813 -5.28307452385 -2.52474602067 -8.89803981813 -5.28307452385 -2.52474602067 -8.89903981813 -5.28307452385 -2.52474602067 -8.90003981813 -5.28307452385 -2.52474602067 -8.90103981813 -5.28307452385 -2.52474602067 -8.90203981813 -5.28307452385 -2.52474602067 -8.90303981813 -5.28307452385 -2.52474602067 -8.90403981813 -5.28307452385 -2.52474602067 -8.90503981813 -5.28307452385 -2.52474602067 -8.90603981813 -5.28307452385 -2.52474602067 -8.90703981813 -5.28307452385 -2.52474602067 -8.90803981813 -5.28307452385 -2.52474602067 -8.90903981813 -5.28307452385 -2.52474602067 -8.91003981813 -5.28307452385 -2.52474602067 -8.91103981813 -5.28307452385 -2.52474602067 -8.91203981813 -5.28307452385 -2.52474602067 -8.91303981813 -5.28307452385 -2.52474602067 -8.91403981813 -5.28307452385 -2.52474602067 -8.91503981813 -5.28307452385 -2.52474602067 -8.91603981813 -5.28307452385 -2.52474602067 -8.91703981813 -5.28307452385 -2.52474602067 -8.91803981813 -5.28307452385 -2.52474602067 -8.91903981813 -5.28307452385 -2.52474602067 -8.92003981813 -5.28307452385 -2.52474602067 -8.92103981813 -3.9516381053 -2.52474602067 -8.92203981813 -3.33932135463 -2.52474602067 -8.92303981813 -40.2895470092 -2.52474602067 -8.92403981813 402.254051186 -2.52474602067 -8.92503981813 402.254051186 -2.52474602067 -8.92603981813 402.254051186 -2.52474602067 -8.92703981813 402.254051186 -2.52474602067 -8.92803981813 402.254051186 -2.52474602067 -8.92903981813 402.254051186 -2.52474602067 -8.93003981813 402.254051186 -2.52474602067 -8.93103981813 402.254051186 -2.52474602067 -8.93203981813 402.254051186 -2.52474602067 -8.93303981813 402.254051186 -2.52474602067 -8.93403981813 402.254051186 -2.52474602067 -8.93503981813 402.254051186 -2.52474602067 -8.93603981813 402.254051186 -2.52474602067 -8.93703981813 402.254051186 -2.52474602067 -8.93803981813 402.254051186 -2.52474602067 -8.93903981813 402.254051186 -2.52474602067 -8.94003981813 402.254051186 -2.52474602067 -8.94103981813 402.254051186 -2.52474602067 -8.94203981813 402.254051186 -2.52474602067 -8.94303981813 402.254051186 -2.52474602067 -8.94403981813 402.254051186 -2.52474602067 -8.94503981813 402.254051186 -2.52474602067 -8.94603981813 402.254051186 -2.52474602067 -8.94703981813 402.254051186 -2.52474602067 -8.94803981813 402.254051186 -2.52474602067 -8.94903981813 402.254051186 -2.52474602067 -8.95003981813 402.254051186 -2.52474602067 -8.95103981813 402.254051186 -2.52474602067 -8.95203981813 402.254051186 -2.52474602067 -8.95303981813 402.254051186 -2.52474602067 -8.95403981813 402.254051186 -2.52474602067 -8.95503981813 402.254051186 -2.52474602067 -8.95603981813 402.254051186 -2.52474602067 -8.95703981813 402.254051186 -2.52474602067 -8.95803981813 402.254051186 -2.52474602067 -8.95903981813 402.254051186 -2.52474602067 -8.96003981813 402.254051186 -2.52474602067 -8.96103981813 402.254051186 -2.52474602067 -8.96203981813 402.254051186 -2.52474602067 -8.96303981813 402.254051186 -2.52474602067 -8.96403981813 402.254051186 -2.52474602067 -8.96503981813 402.254051186 -2.52474602067 -8.96603981813 402.254051186 -2.52474602067 -8.96703981813 402.254051186 -2.52474602067 -8.96803981813 402.254051186 -2.52474602067 -8.96903981813 402.254051186 -2.52474602067 -8.97003981813 402.254051186 -2.52474602067 -8.97103981813 402.254051186 -2.52474602067 -8.97203981813 402.254051186 -2.52474602067 -8.97303981813 402.254051186 -2.52474602067 -8.97403981813 402.254051186 -2.52474602067 -8.97503981813 402.254051186 -2.52474602067 -8.97603981813 402.254051186 -2.52474602067 -8.97703981813 402.254051186 -2.52474602067 -8.97803981813 402.254051186 -2.52474602067 -8.97903981813 402.254051186 -2.52474602067 -8.98003981813 402.254051186 -2.52474602067 -8.98103981813 402.254051186 -2.52474602067 -8.98203981813 402.254051186 -2.52474602067 -8.98303981813 402.254051186 -2.52474602067 -8.98403981813 402.254051186 -2.52474602067 -8.98503981813 402.254051186 -2.52474602067 -8.98603981813 402.254051186 -2.52474602067 -8.98703981813 402.254051186 -2.52474602067 -8.98803981813 402.254051186 -2.52474602067 -8.98903981813 402.254051186 -2.52474602067 -8.99003981813 402.254051186 -2.52474602067 -8.99103981813 402.254051186 -2.52474602067 -8.99203981813 402.254051186 -2.52474602067 -8.99303981813 402.254051186 -2.52474602067 -8.99403981813 402.254051186 -2.52474602067 -8.99503981813 402.254051186 -2.52474602067 -8.99603981813 402.254051186 -2.52474602067 -8.99703981813 402.254051186 -2.52474602067 -8.99803981813 402.254051186 -2.52474602067 -8.99903981813 402.254051186 -2.52474602067 -9.00003981813 402.254051186 -2.52474602067 -9.00103981813 402.254051186 -2.52474602067 -9.00203981813 402.254051186 -2.52474602067 -9.00303981813 402.254051186 -2.52474602067 -9.00403981813 402.254051186 -2.52474602067 -9.00503981813 402.254051186 -2.52474602067 -9.00603981813 402.254051186 -2.52474602067 -9.00703981813 402.254051186 -2.52474602067 -9.00803981813 402.254051186 -2.52474602067 -9.00903981813 402.254051186 -2.52474602067 -9.01003981813 402.254051186 -2.52474602067 -9.01103981813 402.254051186 -2.52474602067 -9.01203981813 402.254051186 -2.52474602067 -9.01303981813 402.254051186 -2.52474602067 -9.01403981813 402.254051186 -2.52474602067 -9.01503981813 402.254051186 -2.52474602067 -9.01603981813 402.254051186 -2.52474602067 -9.01703981813 402.254051186 -2.52474602067 -9.01803981813 402.254051186 -2.52474602067 -9.01903981813 402.254051186 -2.52474602067 -9.02003981813 402.254051186 -2.52474602067 -9.02103981813 402.254051186 -2.52474602067 -9.02203981813 402.254051186 -2.52474602067 -9.02303981813 402.254051186 -2.52474602067 -9.02403981813 402.254051186 -2.52474602067 -9.02503981813 402.254051186 -2.52474602067 -9.02603981813 402.254051186 -2.52474602067 -9.02703981813 402.254051186 -2.52474602067 -9.02803981813 402.254051186 -2.52474602067 -9.02903981813 402.254051186 -2.52474602067 -9.03003981813 402.254051186 -2.52474602067 -9.03103981813 402.254051186 -2.52474602067 -9.03203981813 402.254051186 -2.52474602067 -9.03303981813 402.254051186 -2.52474602067 -9.03403981813 402.254051186 -2.52474602067 -9.03503981813 402.254051186 -2.52474602067 -9.03603981813 402.254051186 -2.52474602067 -9.03703981813 402.254051186 -2.52474602067 -9.03803981813 402.254051186 -2.52474602067 -9.03903981813 402.254051186 -2.52474602067 -9.04003981813 402.254051186 -2.52474602067 -9.04103981813 402.254051186 -2.52474602067 -9.04203981813 402.254051186 -2.52474602067 -9.04303981813 402.254051186 -2.52474602067 -9.04403981813 402.254051186 -2.52474602067 -9.04503981813 402.254051186 -2.52474602067 -9.04603981813 402.254051186 -2.52474602067 -9.04703981813 402.254051186 -2.52474602067 -9.04803981813 402.254051186 -2.52474602067 -9.04903981813 402.254051186 -2.52474602067 -9.05003981813 402.254051186 -2.52474602067 -9.05103981813 402.254051186 -2.52474602067 -9.05203981813 402.254051186 -2.52474602067 -9.05303981813 402.254051186 -2.52474602067 -9.05403981813 402.254051186 -2.52474602067 -9.05503981813 402.254051186 -2.52474602067 -9.05603981813 402.254051186 -2.52474602067 -9.05703981813 402.254051186 -2.52474602067 -9.05803981813 402.254051186 -2.52474602067 -9.05903981813 402.254051186 -2.52474602067 -9.06003981813 402.254051186 -2.52474602067 -9.06103981813 402.254051186 -2.52474602067 -9.06203981813 402.254051186 -2.52474602067 -9.06303981813 402.254051186 -2.52474602067 -9.06403981813 402.254051186 -2.52474602067 -9.06503981813 402.254051186 -2.52474602067 -9.06603981813 402.254051186 -2.52474602067 -9.06703981813 402.254051186 -2.52474602067 -9.06803981813 402.254051186 -2.52474602067 -9.06903981813 402.254051186 -2.52474602067 -9.07003981813 402.254051186 -2.52474602067 -9.07103981813 402.254051186 -2.52474602067 -9.07203981813 402.254051186 -2.52474602067 -9.07303981813 402.254051186 -2.52474602067 -9.07403981813 402.254051186 -2.52474602067 -9.07503981813 402.254051186 -2.52474602067 -9.07603981813 402.254051186 -2.52474602067 -9.07703981813 402.254051186 -2.52474602067 -9.07803981813 402.254051186 -2.52474602067 -9.07903981813 402.254051186 -2.52474602067 -9.08003981813 402.254051186 -2.52474602067 -9.08103981813 402.254051186 -2.52474602067 -9.08203981813 402.254051186 -2.52474602067 -9.08303981813 402.254051186 -2.52474602067 -9.08403981813 402.254051186 -2.52474602067 -9.08503981813 402.254051186 -2.52474602067 -9.08603981813 402.254051186 -2.52474602067 -9.08703981813 402.254051186 -2.52474602067 -9.08803981813 402.254051186 -2.52474602067 -9.08903981813 402.254051186 -2.52474602067 -9.09003981813 402.254051186 -2.52474602067 -9.09103981813 402.254051186 -2.52474602067 -9.09203981813 402.254051186 -2.52474602067 -9.09303981813 402.254051186 -2.52474602067 -9.09403981813 402.254051186 -2.52474602067 -9.09503981813 402.254051186 -2.52474602067 -9.09603981813 402.254051186 -2.52474602067 -9.09703981813 402.254051186 -2.52474602067 -9.09803981813 402.254051186 -2.52474602067 -9.09903981813 402.254051186 -2.52474602067 -9.10003981813 402.254051186 -2.52474602067 -9.10103981813 402.254051186 -2.52474602067 -9.10203981813 402.254051186 -2.52474602067 -9.10303981813 402.254051186 -2.52474602067 -9.10403981813 402.254051186 -2.52474602067 -9.10503981813 402.254051186 -2.52474602067 -9.10603981813 402.254051186 -2.52474602067 -9.10703981813 402.254051186 -2.52474602067 -9.10803981813 402.254051186 -2.52474602067 -9.10903981813 402.254051186 -2.52474602067 -9.11003981813 402.254051186 -2.52474602067 -9.11103981813 402.254051186 -2.52474602067 -9.11203981813 402.254051186 -2.52474602067 -9.11303981813 402.254051186 -2.52474602067 -9.11403981813 402.254051186 -2.52474602067 -9.11503981813 402.254051186 -2.52474602067 -9.11603981813 402.254051186 -2.52474602067 -9.11703981813 402.254051186 -2.52474602067 -9.11803981813 402.254051186 -2.52474602067 -9.11903981813 402.254051186 -2.52474602067 -9.12003981813 402.254051186 -2.52474602067 -9.12103981813 402.254051186 -2.52474602067 -9.12203981813 402.254051186 -2.52474602067 -9.12303981813 402.254051186 -2.52474602067 -9.12403981813 402.254051186 -2.52474602067 -9.12503981813 402.254051186 -2.52474602067 -9.12603981813 402.254051186 -2.52474602067 -9.12703981813 402.254051186 -2.52474602067 -9.12803981813 402.254051186 -2.52474602067 -9.12903981813 402.254051186 -2.52474602067 -9.13003981813 402.254051186 -2.52474602067 -9.13103981813 402.254051186 -2.52474602067 -9.13203981813 402.254051186 -2.52474602067 -9.13303981813 402.254051186 -2.52474602067 -9.13403981813 402.254051186 -2.52474602067 -9.13503981813 402.254051186 -2.52474602067 -9.13603981813 402.254051186 -2.52474602067 -9.13703981813 402.254051186 -2.52474602067 -9.13803981813 402.254051186 -2.52474602067 -9.13903981813 402.254051186 -2.52474602067 -9.14003981813 402.254051186 -2.52474602067 -9.14103981813 402.254051186 -2.52474602067 -9.14203981813 402.254051186 -2.52474602067 -9.14303981813 402.254051186 -2.52474602067 -9.14403981813 402.254051186 -2.52474602067 -9.14503981813 402.254051186 -2.52474602067 -9.14603981813 402.254051186 -2.52474602067 -9.14703981813 402.254051186 -2.52474602067 -9.14803981813 402.254051186 -2.52474602067 -9.14903981813 402.254051186 -2.52474602067 -9.15003981813 402.254051186 -2.52474602067 -9.15103981813 402.254051186 -2.52474602067 -9.15203981813 402.254051186 -2.52474602067 -9.15303981813 402.254051186 -2.52474602067 -9.15403981813 402.254051186 -2.52474602067 -9.15503981813 402.254051186 -2.52474602067 -9.15603981813 402.254051186 -2.52474602067 -9.15703981813 402.254051186 -2.52474602067 -9.15803981813 402.254051186 -2.52474602067 -9.15903981813 402.254051186 -2.52474602067 -9.16003981813 402.254051186 -2.52474602067 -9.16103981813 402.254051186 -2.52474602067 -9.16203981813 402.254051186 -2.52474602067 -9.16303981813 402.254051186 -2.52474602067 -9.16403981813 402.254051186 -2.52474602067 -9.16503981813 402.254051186 -2.52474602067 -9.16603981813 402.254051186 -2.52474602067 -9.16703981813 402.254051186 -2.52474602067 -9.16803981813 402.254051186 -2.52474602067 -9.16903981813 402.254051186 -2.52474602067 -9.17003981813 402.254051186 -2.52474602067 -9.17103981813 402.254051186 -2.52474602067 -9.17203981813 402.254051186 -2.52474602067 -9.17303981813 402.254051186 -2.52474602067 -9.17403981813 402.254051186 -2.52474602067 -9.17503981813 402.254051186 -2.52474602067 -9.17603981813 402.254051186 -2.52474602067 -9.17703981813 402.254051186 -2.52474602067 -9.17803981813 402.254051186 -2.52474602067 -9.17903981813 402.254051186 -2.52474602067 -9.18003981813 402.254051186 -2.52474602067 -9.18103981813 402.254051186 -2.52474602067 -9.18203981813 402.254051186 -2.52474602067 -9.18303981813 402.254051186 -2.52474602067 -9.18403981813 402.254051186 -2.52474602067 -9.18503981813 402.254051186 -2.52474602067 -9.18603981813 402.254051186 -2.52474602067 -9.18703981813 402.254051186 -2.52474602067 -9.18803981813 402.254051186 -2.52474602067 -9.18903981813 402.254051186 -2.52474602067 -9.19003981813 402.254051186 -2.52474602067 -9.19103981813 402.254051186 -2.52474602067 -9.19203981813 402.254051186 -2.52474602067 -9.19303981813 402.254051186 -2.52474602067 -9.19403981813 402.254051186 -2.52474602067 -9.19503981813 402.254051186 -2.52474602067 -9.19603981813 402.254051186 -2.52474602067 -9.19703981813 402.254051186 -2.52474602067 -9.19803981813 402.254051186 -2.52474602067 -9.19903981813 402.254051186 -2.52474602067 -9.20003981813 402.254051186 -2.52474602067 -9.20103981813 402.254051186 -2.52474602067 -9.20203981813 402.254051186 -2.52474602067 -9.20303981813 402.254051186 -2.52474602067 -9.20403981813 402.254051186 -2.52474602067 -9.20503981813 402.254051186 -2.52474602067 -9.20603981813 402.254051186 -2.52474602067 -9.20703981813 402.254051186 -2.52474602067 -9.20803981813 402.254051186 -2.52474602067 -9.20903981813 402.254051186 -2.52474602067 -9.21003981813 402.254051186 -2.52474602067 -9.21103981813 402.254051186 -2.52474602067 -9.21203981813 402.254051186 -2.52474602067 -9.21303981813 402.254051186 -2.52474602067 -9.21403981813 402.254051186 -2.52474602067 -9.21503981813 402.254051186 -2.52474602067 -9.21603981813 402.254051186 -2.52474602067 -9.21703981813 402.254051186 -2.52474602067 -9.21803981813 402.254051186 -2.52474602067 -9.21903981813 402.254051186 -2.52474602067 -9.22003981813 402.254051186 -2.52474602067 -9.22103981813 402.254051186 -2.52474602067 -9.22203981813 402.254051186 -2.52474602067 -9.22303981813 402.254051186 -2.52474602067 -9.22403981813 402.254051186 -2.52474602067 -9.22503981813 402.254051186 -2.52474602067 -9.22603981813 402.254051186 -2.52474602067 -9.22703981813 402.254051186 -2.52474602067 -9.22803981813 402.254051186 -2.52474602067 -9.22903981813 402.254051186 -2.52474602067 -9.23003981813 402.254051186 -2.52474602067 -9.23103981813 402.254051186 -2.52474602067 -9.23203981813 402.254051186 -2.52474602067 -9.23303981813 402.254051186 -2.52474602067 -9.23403981813 402.254051186 -2.52474602067 -9.23503981813 402.254051186 -2.52474602067 -9.23603981813 402.254051186 -2.52474602067 -9.23703981813 402.254051186 -2.52474602067 -9.23803981813 402.254051186 -2.52474602067 -9.23903981813 402.254051186 -2.52474602067 -9.24003981813 402.254051186 -2.52474602067 -9.24103981813 402.254051186 -2.52474602067 -9.24203981813 402.254051186 -2.52474602067 -9.24303981813 402.254051186 -2.52474602067 -9.24403981813 402.254051186 -2.52474602067 -9.24503981813 402.254051186 -2.52474602067 -9.24603981813 402.254051186 -2.52474602067 -9.24703981813 402.254051186 -2.52474602067 -9.24803981813 402.254051186 -2.52474602067 -9.24903981813 402.254051186 -2.52474602067 -9.25003981813 402.254051186 -2.52474602067 -9.25103981813 402.254051186 -2.52474602067 -9.25203981813 402.254051186 -2.52474602067 -9.25303981813 402.254051186 -2.52474602067 -9.25403981813 402.254051186 -2.52474602067 -9.25503981813 402.254051186 -2.52474602067 -9.25603981813 402.254051186 -2.52474602067 -9.25703981813 402.254051186 -2.52474602067 -9.25803981813 402.254051186 -2.52474602067 -9.25903981813 402.254051186 -2.52474602067 -9.26003981813 402.254051186 -2.52474602067 -9.26103981813 402.254051186 -2.52474602067 -9.26203981813 402.254051186 -2.52474602067 -9.26303981813 402.254051186 -2.52474602067 -9.26403981813 402.254051186 -2.52474602067 -9.26503981813 402.254051186 -2.52474602067 -9.26603981813 402.254051186 -2.52474602067 -9.26703981813 402.254051186 -2.52474602067 -9.26803981813 402.254051186 -2.52474602067 -9.26903981813 402.254051186 -2.52474602067 -9.27003981813 402.254051186 -2.52474602067 -9.27103981813 402.254051186 -2.52474602067 -9.27203981813 402.254051186 -2.52474602067 -9.27303981813 402.254051186 -2.52474602067 -9.27403981813 402.254051186 -2.52474602067 -9.27503981813 402.254051186 -2.52474602067 -9.27603981813 402.254051186 -2.52474602067 -9.27703981813 402.254051186 -2.52474602067 -9.27803981813 402.254051186 -2.52474602067 -9.27903981813 402.254051186 -2.52474602067 -9.28003981813 402.254051186 -2.52474602067 -9.28103981813 402.254051186 -2.52474602067 -9.28203981813 402.254051186 -2.52474602067 -9.28303981813 402.254051186 -2.52474602067 -9.28403981813 402.254051186 -2.52474602067 -9.28503981813 402.254051186 -2.52474602067 -9.28603981813 402.254051186 -2.52474602067 -9.28703981813 402.254051186 -2.52474602067 -9.28803981813 402.254051186 -2.52474602067 -9.28903981813 402.254051186 -2.52474602067 -9.29003981813 402.254051186 -2.52474602067 -9.29103981813 402.254051186 -2.52474602067 -9.29203981813 402.254051186 -2.52474602067 -9.29303981813 402.254051186 -2.52474602067 -9.29403981813 402.254051186 -2.52474602067 -9.29503981813 402.254051186 -2.52474602067 -9.29603981813 402.254051186 -2.52474602067 -9.29703981813 402.254051186 -2.52474602067 -9.29803981813 402.254051186 -2.52474602067 -9.29903981813 402.254051186 -2.52474602067 -9.30003981813 402.254051186 -2.52474602067 -9.30103981813 402.254051186 -2.52474602067 -9.30203981813 402.254051186 -2.52474602067 -9.30303981813 402.254051186 -2.52474602067 -9.30403981813 402.254051186 -2.52474602067 -9.30503981813 402.254051186 -2.52474602067 -9.30603981813 402.254051186 -2.52474602067 -9.30703981813 402.254051186 -2.52474602067 -9.30803981813 402.254051186 -2.52474602067 -9.30903981813 402.254051186 -2.52474602067 -9.31003981813 402.254051186 -2.52474602067 -9.31103981813 402.254051186 -2.52474602067 -9.31203981813 402.254051186 -2.52474602067 -9.31303981813 402.254051186 -2.52474602067 -9.31403981813 402.254051186 -2.52474602067 -9.31503981813 402.254051186 -2.52474602067 -9.31603981813 402.254051186 -2.52474602067 -9.31703981813 402.254051186 -2.52474602067 -9.31803981813 402.254051186 -2.52474602067 -9.31903981813 402.254051186 -2.52474602067 -9.32003981813 402.254051186 -2.52474602067 -9.32103981813 402.254051186 -2.52474602067 -9.32203981813 402.254051186 -2.52474602067 -9.32303981813 402.254051186 -2.52474602067 -9.32403981813 402.254051186 -2.52474602067 -9.32503981813 402.254051186 -2.52474602067 -9.32603981813 402.254051186 -2.52474602067 -9.32703981813 402.254051186 -2.52474602067 -9.32803981813 402.254051186 -2.52474602067 -9.32903981813 402.254051186 -2.52474602067 -9.33003981813 402.254051186 -2.52474602067 -9.33103981813 402.254051186 -2.52474602067 -9.33203981813 402.254051186 -2.52474602067 -9.33303981813 402.254051186 -2.52474602067 -9.33403981813 402.254051186 -2.52474602067 -9.33503981813 402.254051186 -2.52474602067 -9.33603981813 402.254051186 -2.52474602067 -9.33703981813 402.254051186 -2.52474602067 -9.33803981813 402.254051186 -2.52474602067 -9.33903981813 402.254051186 -2.52474602067 -9.34003981813 402.254051186 -2.52474602067 -9.34103981813 402.254051186 -2.52474602067 -9.34203981813 402.254051186 -2.52474602067 -9.34303981813 402.254051186 -2.52474602067 -9.34403981813 402.254051186 -2.52474602067 -9.34503981813 402.254051186 -2.52474602067 -9.34603981813 402.254051186 -2.52474602067 -9.34703981813 402.254051186 -2.52474602067 -9.34803981813 402.254051186 -2.52474602067 -9.34903981813 402.254051186 -2.52474602067 -9.35003981813 402.254051186 -2.52474602067 -9.35103981813 402.254051186 -2.52474602067 -9.35203981813 402.254051186 -2.52474602067 -9.35303981813 402.254051186 -2.52474602067 -9.35403981813 402.254051186 -2.52474602067 -9.35503981813 402.254051186 -2.52474602067 -9.35603981813 402.254051186 -2.52474602067 -9.35703981813 402.254051186 -2.52474602067 -9.35803981813 402.254051186 -2.52474602067 -9.35903981813 402.254051186 -2.52474602067 -9.36003981813 402.254051186 -2.52474602067 -9.36103981813 402.254051186 -2.52474602067 -9.36203981813 402.254051186 -2.52474602067 -9.36303981813 402.254051186 -2.52474602067 -9.36403981813 402.254051186 -2.52474602067 -9.36503981813 402.254051186 -2.52474602067 -9.36603981813 402.254051186 -2.52474602067 -9.36703981813 402.254051186 -2.52474602067 -9.36803981813 402.254051186 -2.52474602067 -9.36903981813 402.254051186 -2.52474602067 -9.37003981813 402.254051186 -2.52474602067 -9.37103981813 402.254051186 -2.52474602067 -9.37203981813 402.254051186 -2.52474602067 -9.37303981813 402.254051186 -2.52474602067 -9.37403981813 402.254051186 -2.52474602067 -9.37503981813 402.254051186 -2.52474602067 -9.37603981813 402.254051186 -2.52474602067 -9.37703981813 402.254051186 -2.52474602067 -9.37803981813 402.254051186 -2.52474602067 -9.37903981813 402.254051186 -2.52474602067 -9.38003981813 402.254051186 -2.52474602067 -9.38103981813 402.254051186 -2.52474602067 -9.38203981813 402.254051186 -2.52474602067 -9.38303981813 402.254051186 -2.52474602067 -9.38403981813 402.254051186 -2.52474602067 -9.38503981813 402.254051186 -2.52474602067 -9.38603981813 402.254051186 -2.52474602067 -9.38703981813 402.254051186 -2.52474602067 -9.38803981813 402.254051186 -2.52474602067 -9.38903981813 402.254051186 -2.52474602067 -9.39003981813 402.254051186 -2.52474602067 -9.39103981813 402.254051186 -2.52474602067 -9.39203981813 402.254051186 -2.52474602067 -9.39303981813 402.254051186 -2.52474602067 -9.39403981813 402.254051186 -2.52474602067 -9.39503981813 402.254051186 -2.52474602067 -9.39603981813 402.254051186 -2.52474602067 -9.39703981813 402.254051186 -2.52474602067 -9.39803981813 402.254051186 -2.52474602067 -9.39903981813 402.254051186 -2.52474602067 -9.40003981813 402.254051186 -2.52474602067 -9.40103981813 402.254051186 -2.52474602067 -9.40203981813 402.254051186 -2.52474602067 -9.40303981813 402.254051186 -2.52474602067 -9.40403981813 402.254051186 -2.52474602067 -9.40503981813 402.254051186 -2.52474602067 -9.40603981813 402.254051186 -2.52474602067 -9.40703981813 402.254051186 -2.52474602067 -9.40803981813 402.254051186 -2.52474602067 -9.40903981813 402.254051186 -2.52474602067 -9.41003981813 402.254051186 -2.52474602067 -9.41103981813 402.254051186 -2.52474602067 -9.41203981813 402.254051186 -2.52474602067 -9.41303981813 402.254051186 -2.52474602067 -9.41403981813 402.254051186 -2.52474602067 -9.41503981813 402.254051186 -2.52474602067 -9.41603981813 402.254051186 -2.52474602067 -9.41703981813 402.254051186 -2.52474602067 -9.41803981813 402.254051186 -2.52474602067 -9.41903981813 402.254051186 -2.52474602067 -9.42003981813 402.254051186 -2.52474602067 -9.42103981813 402.254051186 -2.52474602067 -9.42203981813 402.254051186 -2.52474602067 -9.42303981813 402.254051186 -2.52474602067 -9.42403981813 402.254051186 -2.52474602067 -9.42503981813 402.254051186 -2.52474602067 -9.42603981813 402.254051186 -2.52474602067 -9.42703981813 402.254051186 -2.52474602067 -9.42803981813 402.254051186 -2.52474602067 -9.42903981813 402.254051186 -2.52474602067 -9.43003981813 402.254051186 -2.52474602067 -9.43103981813 402.254051186 -2.52474602067 -9.43203981813 402.254051186 -2.52474602067 -9.43303981813 402.254051186 -2.52474602067 -9.43403981813 402.254051186 -2.52474602067 -9.43503981813 402.254051186 -2.52474602067 -9.43603981813 402.254051186 -2.52474602067 -9.43703981813 402.254051186 -2.52474602067 -9.43803981813 402.254051186 -2.52474602067 -9.43903981813 402.254051186 -2.52474602067 -9.44003981813 402.254051186 -2.52474602067 -9.44103981813 402.254051186 -2.52474602067 -9.44203981813 402.254051186 -2.52474602067 -9.44303981813 402.254051186 -2.52474602067 -9.44403981813 402.254051186 -2.52474602067 -9.44503981813 402.254051186 -2.52474602067 -9.44603981813 402.254051186 -2.52474602067 -9.44703981813 402.254051186 -2.52474602067 -9.44803981813 402.254051186 -2.52474602067 -9.44903981813 402.254051186 -2.52474602067 -9.45003981813 402.254051186 -2.52474602067 -9.45103981813 402.254051186 -2.52474602067 -9.45203981813 402.254051186 -2.52474602067 -9.45303981813 402.254051186 -2.52474602067 -9.45403981813 402.254051186 -2.52474602067 -9.45503981813 402.254051186 -2.52474602067 -9.45603981813 402.254051186 -2.52474602067 -9.45703981813 402.254051186 -2.52474602067 -9.45803981813 402.254051186 -2.52474602067 -9.45903981813 402.254051186 -2.52474602067 -9.46003981813 402.254051186 -2.52474602067 -9.46103981813 402.254051186 -2.52474602067 -9.46203981813 402.254051186 -2.52474602067 -9.46303981813 402.254051186 -2.52474602067 -9.46403981813 402.254051186 -2.52474602067 -9.46503981813 402.254051186 -2.52474602067 -9.46603981813 402.254051186 -2.52474602067 -9.46703981813 402.254051186 -2.52474602067 -9.46803981813 402.254051186 -2.52474602067 -9.46903981813 402.254051186 -2.52474602067 -9.47003981813 402.254051186 -2.52474602067 -9.47103981813 402.254051186 -2.52474602067 -9.47203981813 402.254051186 -2.52474602067 -9.47303981813 402.254051186 -2.52474602067 -9.47403981813 402.254051186 -2.52474602067 -9.47503981813 402.254051186 -2.52474602067 -9.47603981813 402.254051186 -2.52474602067 -9.47703981813 402.254051186 -2.52474602067 -9.47803981813 402.254051186 -2.52474602067 -9.47903981813 402.254051186 -2.52474602067 -9.48003981813 402.254051186 -2.52474602067 -9.48103981813 402.254051186 -2.52474602067 -9.48203981813 402.254051186 -2.52474602067 -9.48303981813 402.254051186 -2.52474602067 -9.48403981813 402.254051186 -2.52474602067 -9.48503981813 402.254051186 -2.52474602067 -9.48603981813 402.254051186 -2.52474602067 -9.48703981813 402.254051186 -2.52474602067 -9.48803981813 402.254051186 -2.52474602067 -9.48903981813 402.254051186 -2.52474602067 -9.49003981813 402.254051186 -2.52474602067 -9.49103981813 402.254051186 -2.52474602067 -9.49203981813 402.254051186 -2.52474602067 -9.49303981813 402.254051186 -2.52474602067 -9.49403981813 402.254051186 -2.52474602067 -9.49503981813 402.254051186 -2.52474602067 -9.49603981813 402.254051186 -2.52474602067 -9.49703981813 402.254051186 -2.52474602067 -9.49803981813 402.254051186 -2.52474602067 -9.49903981813 402.254051186 -2.52474602067 -9.50003981813 402.254051186 -2.52474602067 -9.50103981813 402.254051186 -2.52474602067 -9.50203981813 402.254051186 -2.52474602067 -9.50303981813 402.254051186 -2.52474602067 -9.50403981813 402.254051186 -2.52474602067 -9.50503981813 402.254051186 -2.52474602067 -9.50603981813 402.254051186 -2.52474602067 -9.50703981813 402.254051186 -2.52474602067 -9.50803981813 402.254051186 -2.52474602067 -9.50903981813 402.254051186 -2.52474602067 -9.51003981813 402.254051186 -2.52474602067 -9.51103981813 402.254051186 -2.52474602067 -9.51203981813 402.254051186 -2.52474602067 -9.51303981813 402.254051186 -2.52474602067 -9.51403981813 402.254051186 -2.52474602067 -9.51503981813 402.254051186 -2.52474602067 -9.51603981813 402.254051186 -2.52474602067 -9.51703981813 402.254051186 -2.52474602067 -9.51803981813 402.254051186 -2.52474602067 -9.51903981813 402.254051186 -2.52474602067 -9.52003981813 402.254051186 -2.52474602067 -9.52103981813 402.254051186 -2.52474602067 -9.52203981813 402.254051186 -2.52474602067 -9.52303981813 402.254051186 -2.52474602067 -9.52403981813 402.254051186 -2.52474602067 -9.52503981813 402.254051186 -2.52474602067 -9.52603981813 402.254051186 -2.52474602067 -9.52703981813 402.254051186 -2.52474602067 -9.52803981813 402.254051186 -2.52474602067 -9.52903981813 402.254051186 -2.52474602067 -9.53003981813 402.254051186 -2.52474602067 -9.53103981813 402.254051186 -2.52474602067 -9.53203981813 402.254051186 -2.52474602067 -9.53303981813 402.254051186 -2.52474602067 -9.53403981813 402.254051186 -2.52474602067 -9.53503981813 402.254051186 -2.52474602067 -9.53603981813 402.254051186 -2.52474602067 -9.53703981813 402.254051186 -2.52474602067 -9.53803981813 402.254051186 -2.52474602067 -9.53903981813 402.254051186 -2.52474602067 -9.54003981813 402.254051186 -2.52474602067 -9.54103981813 402.254051186 -2.52474602067 -9.54203981813 402.254051186 -2.52474602067 -9.54303981813 402.254051186 -2.52474602067 -9.54403981813 402.254051186 -2.52474602067 -9.54503981813 402.254051186 -2.52474602067 -9.54603981813 402.254051186 -2.52474602067 -9.54703981813 402.254051186 -2.52474602067 -9.54803981813 402.254051186 -2.52474602067 -9.54903981813 402.254051186 -2.52474602067 -9.55003981813 402.254051186 -2.52474602067 -9.55103981813 402.254051186 -2.52474602067 -9.55203981813 402.254051186 -2.52474602067 -9.55303981813 402.254051186 -2.52474602067 -9.55403981813 402.254051186 -2.52474602067 -9.55503981813 402.254051186 -2.52474602067 -9.55603981813 402.254051186 -2.52474602067 -9.55703981813 402.254051186 -2.52474602067 -9.55803981813 402.254051186 -2.52474602067 -9.55903981813 402.254051186 -2.52474602067 -9.56003981813 402.254051186 -2.52474602067 -9.56103981813 402.254051186 -2.52474602067 -9.56203981813 402.254051186 -2.52474602067 -9.56303981813 402.254051186 -2.52474602067 -9.56403981813 402.254051186 -2.52474602067 -9.56503981813 402.254051186 -2.52474602067 -9.56603981813 402.254051186 -2.52474602067 -9.56703981813 402.254051186 -2.52474602067 -9.56803981813 402.254051186 -2.52474602067 -9.56903981813 402.254051186 -2.52474602067 -9.57003981813 402.254051186 -2.52474602067 -9.57103981813 402.254051186 -2.52474602067 -9.57203981813 402.254051186 -2.52474602067 -9.57303981813 402.254051186 -2.52474602067 -9.57403981813 402.254051186 -2.52474602067 -9.57503981813 402.254051186 -2.52474602067 -9.57603981813 402.254051186 -2.52474602067 -9.57703981813 402.254051186 -2.52474602067 -9.57803981813 402.254051186 -2.52474602067 -9.57903981813 402.254051186 -2.52474602067 -9.58003981813 402.254051186 -2.52474602067 -9.58103981813 402.254051186 -2.52474602067 -9.58203981813 402.254051186 -2.52474602067 -9.58303981813 402.254051186 -2.52474602067 -9.58403981813 402.254051186 -2.52474602067 -9.58503981813 402.254051186 -2.52474602067 -9.58603981813 402.254051186 -2.52474602067 -9.58703981813 402.254051186 -2.52474602067 -9.58803981813 402.254051186 -2.52474602067 -9.58903981813 402.254051186 -2.52474602067 -9.59003981813 402.254051186 -2.52474602067 -9.59103981813 402.254051186 -2.52474602067 -9.59203981813 402.254051186 -2.52474602067 -9.59303981813 402.254051186 -2.52474602067 -9.59403981813 402.254051186 -2.52474602067 -9.59503981813 402.254051186 -2.52474602067 -9.59603981813 402.254051186 -2.52474602067 -9.59703981813 402.254051186 -2.52474602067 -9.59803981813 402.254051186 -2.52474602067 -9.59903981813 402.254051186 -2.52474602067 -9.60003981813 402.254051186 -2.52474602067 -9.60103981813 402.254051186 -2.52474602067 -9.60203981813 402.254051186 -2.52474602067 -9.60303981813 402.254051186 -2.52474602067 -9.60403981813 402.254051186 -2.52474602067 -9.60503981813 402.254051186 -2.52474602067 -9.60603981813 402.254051186 -2.52474602067 -9.60703981813 402.254051186 -2.52474602067 -9.60803981813 402.254051186 -2.52474602067 -9.60903981813 402.254051186 -2.52474602067 -9.61003981813 402.254051186 -2.52474602067 -9.61103981813 402.254051186 -2.52474602067 -9.61203981813 402.254051186 -2.52474602067 -9.61303981813 402.254051186 -2.52474602067 -9.61403981813 402.254051186 -2.52474602067 -9.61503981813 402.254051186 -2.52474602067 -9.61603981813 402.254051186 -2.52474602067 -9.61703981813 402.254051186 -2.52474602067 -9.61803981813 402.254051186 -2.52474602067 -9.61903981813 402.254051186 -2.52474602067 -9.62003981813 402.254051186 -2.52474602067 -9.62103981813 402.254051186 -2.52474602067 -9.62203981813 402.254051186 -2.52474602067 -9.62303981813 402.254051186 -2.52474602067 -9.62403981813 402.254051186 -2.52474602067 -9.62503981813 402.254051186 -2.52474602067 -9.62603981813 402.254051186 -2.52474602067 -9.62703981813 402.254051186 -2.52474602067 -9.62803981813 402.254051186 -2.52474602067 -9.62903981813 402.254051186 -2.52474602067 -9.63003981813 402.254051186 -2.52474602067 -9.63103981813 402.254051186 -2.52474602067 -9.63203981813 402.254051186 -2.52474602067 -9.63303981813 402.254051186 -2.52474602067 -9.63403981813 402.254051186 -2.52474602067 -9.63503981813 402.254051186 -2.52474602067 -9.63603981813 402.254051186 -2.52474602067 -9.63703981813 402.254051186 -2.52474602067 -9.63803981813 402.254051186 -2.52474602067 -9.63903981813 402.254051186 -2.52474602067 -9.64003981813 402.254051186 -2.52474602067 -9.64103981813 402.254051186 -2.52474602067 -9.64203981813 402.254051186 -2.52474602067 -9.64303981813 402.254051186 -2.52474602067 -9.64403981813 402.254051186 -2.52474602067 -9.64503981813 402.254051186 -2.52474602067 -9.64603981813 402.254051186 -2.52474602067 -9.64703981813 402.254051186 -2.52474602067 -9.64803981813 402.254051186 -2.52474602067 -9.64903981813 402.254051186 -2.52474602067 -9.65003981813 402.254051186 -2.52474602067 -9.65103981813 402.254051186 -2.52474602067 -9.65203981813 402.254051186 -2.52474602067 -9.65303981813 402.254051186 -2.52474602067 -9.65403981813 402.254051186 -2.52474602067 -9.65503981813 402.254051186 -2.52474602067 -9.65603981813 402.254051186 -2.52474602067 -9.65703981813 402.254051186 -2.52474602067 -9.65803981813 402.254051186 -2.52474602067 -9.65903981813 402.254051186 -2.52474602067 -9.66003981813 402.254051186 -2.52474602067 -9.66103981813 402.254051186 -2.52474602067 -9.66203981813 402.254051186 -2.52474602067 -9.66303981813 402.254051186 -2.52474602067 -9.66403981813 402.254051186 -2.52474602067 -9.66503981813 402.254051186 -2.52474602067 -9.66603981813 402.254051186 -2.52474602067 -9.66703981813 402.254051186 -2.52474602067 -9.66803981813 402.254051186 -2.52474602067 -9.66903981813 402.254051186 -2.52474602067 -9.67003981813 402.254051186 -2.52474602067 -9.67103981813 402.254051186 -2.52474602067 -9.67203981813 402.254051186 -2.52474602067 -9.67303981813 402.254051186 -2.52474602067 -9.67403981813 402.254051186 -2.52474602067 -9.67503981813 402.254051186 -2.52474602067 -9.67603981813 402.254051186 -2.52474602067 -9.67703981813 402.254051186 -2.52474602067 -9.67803981813 402.254051186 -2.52474602067 -9.67903981813 402.254051186 -2.52474602067 -9.68003981813 402.254051186 -2.52474602067 -9.68103981813 402.254051186 -2.52474602067 -9.68203981813 402.254051186 -2.52474602067 -9.68303981813 402.254051186 -2.52474602067 -9.68403981813 402.254051186 -2.52474602067 -9.68503981813 402.254051186 -2.52474602067 -9.68603981813 402.254051186 -2.52474602067 -9.68703981813 402.254051186 -2.52474602067 -9.68803981813 402.254051186 -2.52474602067 -9.68903981813 402.254051186 -2.52474602067 -9.69003981813 402.254051186 -2.52474602067 -9.69103981813 402.254051186 -2.52474602067 -9.69203981813 402.254051186 -2.52474602067 -9.69303981813 402.254051186 -2.52474602067 -9.69403981813 402.254051186 -2.52474602067 -9.69503981813 402.254051186 -2.52474602067 -9.69603981813 402.254051186 -2.52474602067 -9.69703981813 402.254051186 -2.52474602067 -9.69803981813 402.254051186 -2.52474602067 -9.69903981813 402.254051186 -2.52474602067 -9.70003981813 402.254051186 -2.52474602067 -9.70103981813 402.254051186 -2.52474602067 -9.70203981813 402.254051186 -2.52474602067 -9.70303981813 402.254051186 -2.52474602067 -9.70403981813 402.254051186 -2.52474602067 -9.70503981813 402.254051186 -2.52474602067 -9.70603981813 402.254051186 -2.52474602067 -9.70703981813 402.254051186 -2.52474602067 -9.70803981813 402.254051186 -2.52474602067 -9.70903981813 402.254051186 -2.52474602067 -9.71003981813 402.254051186 -2.52474602067 -9.71103981813 402.254051186 -2.52474602067 -9.71203981813 402.254051186 -2.52474602067 -9.71303981813 402.254051186 -2.52474602067 -9.71403981813 402.254051186 -2.52474602067 -9.71503981813 402.254051186 -2.52474602067 -9.71603981813 402.254051186 -2.52474602067 -9.71703981813 402.254051186 -2.52474602067 -9.71803981813 402.254051186 -2.52474602067 -9.71903981813 402.254051186 -2.52474602067 -9.72003981813 402.254051186 -2.52474602067 -9.72103981813 402.254051186 -2.52474602067 -9.72203981813 402.254051186 -2.52474602067 -9.72303981813 402.254051186 -2.52474602067 -9.72403981813 402.254051186 -2.52474602067 -9.72503981813 402.254051186 -2.52474602067 -9.72603981813 402.254051186 -2.52474602067 -9.72703981813 402.254051186 -2.52474602067 -9.72803981813 402.254051186 -2.52474602067 -9.72903981813 402.254051186 -2.52474602067 -9.73003981813 402.254051186 -2.52474602067 -9.73103981813 402.254051186 -2.52474602067 -9.73203981813 402.254051186 -2.52474602067 -9.73303981813 402.254051186 -2.52474602067 -9.73403981813 402.254051186 -2.52474602067 -9.73503981813 402.254051186 -2.52474602067 -9.73603981813 402.254051186 -2.52474602067 -9.73703981813 402.254051186 -2.52474602067 -9.73803981813 402.254051186 -2.52474602067 -9.73903981813 402.254051186 -2.52474602067 -9.74003981813 402.254051186 -2.52474602067 -9.74103981813 402.254051186 -2.52474602067 -9.74203981813 402.254051186 -2.52474602067 -9.74303981813 402.254051186 -2.52474602067 -9.74403981813 402.254051186 -2.52474602067 -9.74503981813 402.254051186 -2.52474602067 -9.74603981813 402.254051186 -2.52474602067 -9.74703981813 402.254051186 -2.52474602067 -9.74803981813 402.254051186 -2.52474602067 -9.74903981813 402.254051186 -2.52474602067 -9.75003981813 402.254051186 -2.52474602067 -9.75103981813 402.254051186 -2.52474602067 -9.75203981813 402.254051186 -2.52474602067 -9.75303981813 402.254051186 -2.52474602067 -9.75403981813 402.254051186 -2.52474602067 -9.75503981813 402.254051186 -2.52474602067 -9.75603981813 402.254051186 -2.52474602067 -9.75703981813 402.254051186 -2.52474602067 -9.75803981813 402.254051186 -2.52474602067 -9.75903981813 402.254051186 -2.52474602067 -9.76003981813 402.254051186 -2.52474602067 -9.76103981813 402.254051186 -2.52474602067 -9.76203981813 402.254051186 -2.52474602067 -9.76303981813 402.254051186 -2.52474602067 -9.76403981813 402.254051186 -2.52474602067 -9.76503981813 402.254051186 -2.52474602067 -9.76603981813 402.254051186 -2.52474602067 -9.76703981813 402.254051186 -2.52474602067 -9.76803981813 402.254051186 -2.52474602067 -9.76903981813 402.254051186 -2.52474602067 -9.77003981813 402.254051186 -2.52474602067 -9.77103981813 402.254051186 -2.52474602067 -9.77203981813 402.254051186 -2.52474602067 -9.77303981813 402.254051186 -2.52474602067 -9.77403981813 402.254051186 -2.52474602067 -9.77503981813 402.254051186 -2.52474602067 -9.77603981813 402.254051186 -2.52474602067 -9.77703981813 402.254051186 -2.52474602067 -9.77803981813 402.254051186 -2.52474602067 -9.77903981813 402.254051186 -2.52474602067 -9.78003981813 402.254051186 -2.52474602067 -9.78103981813 402.254051186 -2.52474602067 -9.78203981813 402.254051186 -2.52474602067 -9.78303981813 402.254051186 -2.52474602067 -9.78403981813 402.254051186 -2.52474602067 -9.78503981813 402.254051186 -2.52474602067 -9.78603981813 402.254051186 -2.52474602067 -9.78703981813 402.254051186 -2.52474602067 -9.78803981813 402.254051186 -2.52474602067 -9.78903981813 402.254051186 -2.52474602067 -9.79003981813 402.254051186 -2.52474602067 -9.79103981813 402.254051186 -2.52474602067 -9.79203981813 402.254051186 -2.52474602067 -9.79303981813 402.254051186 -2.52474602067 -9.79403981813 402.254051186 -2.52474602067 -9.79503981813 402.254051186 -2.52474602067 -9.79603981813 402.254051186 -2.52474602067 -9.79703981813 402.254051186 -2.52474602067 -9.79803981813 402.254051186 -2.52474602067 -9.79903981813 402.254051186 -2.52474602067 -9.80003981813 402.254051186 -2.52474602067 -9.80103981813 402.254051186 -2.52474602067 -9.80203981813 402.254051186 -2.52474602067 -9.80303981813 402.254051186 -2.52474602067 -9.80403981813 402.254051186 -2.52474602067 -9.80503981813 402.254051186 -2.52474602067 -9.80603981813 402.254051186 -2.52474602067 -9.80703981813 402.254051186 -2.52474602067 -9.80803981813 402.254051186 -2.52474602067 -9.80903981813 402.254051186 -2.52474602067 -9.81003981813 402.254051186 -2.52474602067 -9.81103981813 402.254051186 -2.52474602067 -9.81203981813 402.254051186 -2.52474602067 -9.81303981813 402.254051186 -2.52474602067 -9.81403981813 402.254051186 -2.52474602067 -9.81503981813 402.254051186 -2.52474602067 -9.81603981813 402.254051186 -2.52474602067 -9.81703981813 402.254051186 -2.52474602067 -9.81803981813 402.254051186 -2.52474602067 -9.81903981813 402.254051186 -2.52474602067 -9.82003981813 402.254051186 -2.52474602067 -9.82103981813 402.254051186 -2.52474602067 -9.82203981813 402.254051186 -2.52474602067 -9.82303981813 402.254051186 -2.52474602067 -9.82403981813 402.254051186 -2.52474602067 -9.82503981813 402.254051186 -2.52474602067 -9.82603981813 402.254051186 -2.52474602067 -9.82703981813 402.254051186 -2.52474602067 -9.82803981813 402.254051186 -2.52474602067 -9.82903981813 402.254051186 -2.52474602067 -9.83003981813 402.254051186 -2.52474602067 -9.83103981813 402.254051186 -2.52474602067 -9.83203981813 402.254051186 -2.52474602067 -9.83303981813 402.254051186 -2.52474602067 -9.83403981813 402.254051186 -2.52474602067 -9.83503981813 402.254051186 -2.52474602067 -9.83603981813 402.254051186 -2.52474602067 -9.83703981813 402.254051186 -2.52474602067 -9.83803981813 402.254051186 -2.52474602067 -9.83903981813 402.254051186 -2.52474602067 -9.84003981813 402.254051186 -2.52474602067 -9.84103981813 402.254051186 -2.52474602067 -9.84203981813 402.254051186 -2.52474602067 -9.84303981813 402.254051186 -2.52474602067 -9.84403981813 402.254051186 -2.52474602067 -9.84503981813 402.254051186 -2.52474602067 -9.84603981813 402.254051186 -2.52474602067 -9.84703981813 402.254051186 -2.52474602067 -9.84803981813 402.254051186 -2.52474602067 -9.84903981813 402.254051186 -2.52474602067 -9.85003981813 402.254051186 -2.52474602067 -9.85103981813 402.254051186 -2.52474602067 -9.85203981813 402.254051186 -2.52474602067 -9.85303981813 402.254051186 -2.52474602067 -9.85403981813 402.254051186 -2.52474602067 -9.85503981813 402.254051186 -2.52474602067 -9.85603981813 402.254051186 -2.52474602067 -9.85703981813 402.254051186 -2.52474602067 -9.85803981813 402.254051186 -2.52474602067 -9.85903981813 402.254051186 -2.52474602067 -9.86003981813 402.254051186 -2.52474602067 -9.86103981813 402.254051186 -2.52474602067 -9.86203981813 402.254051186 -2.52474602067 -9.86303981813 402.254051186 -2.52474602067 -9.86403981813 402.254051186 -2.52474602067 -9.86503981813 402.254051186 -2.52474602067 -9.86603981813 402.254051186 -2.52474602067 -9.86703981813 402.254051186 -2.52474602067 -9.86803981813 402.254051186 -2.52474602067 -9.86903981813 402.254051186 -2.52474602067 -9.87003981813 402.254051186 -2.52474602067 -9.87103981813 402.254051186 -2.52474602067 -9.87203981813 402.254051186 -2.52474602067 -9.87303981813 402.254051186 -2.52474602067 -9.87403981813 402.254051186 -2.52474602067 -9.87503981813 402.254051186 -2.52474602067 -9.87603981813 402.254051186 -2.52474602067 -9.87703981813 402.254051186 -2.52474602067 -9.87803981813 402.254051186 -2.52474602067 -9.87903981813 402.254051186 -2.52474602067 -9.88003981813 402.254051186 -2.52474602067 -9.88103981813 402.254051186 -2.52474602067 -9.88203981813 402.254051186 -2.52474602067 -9.88303981813 402.254051186 -2.52474602067 -9.88403981813 402.254051186 -2.52474602067 -9.88503981813 402.254051186 -2.52474602067 -9.88603981813 402.254051186 -2.52474602067 -9.88703981813 402.254051186 -2.52474602067 -9.88803981813 402.254051186 -2.52474602067 -9.88903981813 402.254051186 -2.52474602067 -9.89003981813 402.254051186 -2.52474602067 -9.89103981813 402.254051186 -2.52474602067 -9.89203981813 402.254051186 -2.52474602067 -9.89303981813 402.254051186 -2.52474602067 -9.89403981813 402.254051186 -2.52474602067 -9.89503981813 402.254051186 -2.52474602067 -9.89603981813 402.254051186 -2.52474602067 -9.89703981813 402.254051186 -2.52474602067 -9.89803981813 402.254051186 -2.52474602067 -9.89903981813 402.254051186 -2.52474602067 -9.90003981813 402.254051186 -2.52474602067 -9.90103981813 402.254051186 -2.52474602067 -9.90203981813 402.254051186 -2.52474602067 -9.90303981813 402.254051186 -2.52474602067 -9.90403981813 402.254051186 -2.52474602067 -9.90503981813 402.254051186 -2.52474602067 -9.90603981813 402.254051186 -2.52474602067 -9.90703981813 402.254051186 -2.52474602067 -9.90803981813 402.254051186 -2.52474602067 -9.90903981813 402.254051186 -2.52474602067 -9.91003981813 402.254051186 -2.52474602067 -9.91103981813 402.254051186 -2.52474602067 -9.91203981813 402.254051186 -2.52474602067 -9.91303981813 402.254051186 -2.52474602067 -9.91403981813 402.254051186 -2.52474602067 -9.91503981813 402.254051186 -2.52474602067 -9.91603981813 402.254051186 -2.52474602067 -9.91703981813 402.254051186 -2.52474602067 -9.91803981813 402.254051186 -2.52474602067 -9.91903981813 402.254051186 -2.52474602067 -9.92003981813 402.254051186 -2.52474602067 -9.92103981813 402.254051186 -2.52474602067 -9.92203981813 402.254051186 -2.52474602067 -9.92303981813 402.254051186 -2.52474602067 -9.92403981813 402.254051186 -2.52474602067 -9.92503981813 402.254051186 -2.52474602067 -9.92603981813 402.254051186 -2.52474602067 -9.92703981813 402.254051186 -2.52474602067 -9.92803981813 402.254051186 -2.52474602067 -9.92903981813 402.254051186 -2.52474602067 -9.93003981813 402.254051186 -2.52474602067 -9.93103981813 402.254051186 -2.52474602067 -9.93203981813 402.254051186 -2.52474602067 -9.93303981813 402.254051186 -2.52474602067 -9.93403981813 402.254051186 -2.52474602067 -9.93503981813 402.254051186 -2.52474602067 -9.93603981813 402.254051186 -2.52474602067 -9.93703981813 402.254051186 -2.52474602067 -9.93803981813 402.254051186 -2.52474602067 -9.93903981813 402.254051186 -2.52474602067 -9.94003981813 402.254051186 -2.52474602067 -9.94103981813 402.254051186 -2.52474602067 -9.94203981813 402.254051186 -2.52474602067 -9.94303981813 402.254051186 -2.52474602067 -9.94403981813 402.254051186 -2.52474602067 -9.94503981813 402.254051186 -2.52474602067 -9.94603981813 402.254051186 -2.52474602067 -9.94703981813 402.254051186 -2.52474602067 -9.94803981813 402.254051186 -2.52474602067 -9.94903981813 402.254051186 -2.52474602067 -9.95003981813 402.254051186 -2.52474602067 -9.95103981813 402.254051186 -2.52474602067 -9.95203981813 402.254051186 -2.52474602067 -9.95303981813 402.254051186 -2.52474602067 -9.95403981813 402.254051186 -2.52474602067 -9.95503981813 402.254051186 -2.52474602067 -9.95603981813 402.254051186 -2.52474602067 -9.95703981813 402.254051186 -2.52474602067 -9.95803981813 402.254051186 -2.52474602067 -9.95903981813 402.254051186 -2.52474602067 -9.96003981813 402.254051186 -2.52474602067 -9.96103981813 402.254051186 -2.52474602067 -9.96203981813 402.254051186 -2.52474602067 -9.96303981813 402.254051186 -2.52474602067 -9.96403981813 402.254051186 -2.52474602067 -9.96503981813 402.254051186 -2.52474602067 -9.96603981813 402.254051186 -2.52474602067 -9.96703981813 402.254051186 -2.52474602067 -9.96803981813 402.254051186 -2.52474602067 -9.96903981813 402.254051186 -2.52474602067 -9.97003981813 402.254051186 -2.52474602067 -9.97103981813 402.254051186 -2.52474602067 -9.97203981813 402.254051186 -2.52474602067 -9.97303981813 402.254051186 -2.52474602067 -9.97403981813 402.254051186 -2.52474602067 -9.97503981813 402.254051186 -2.52474602067 -9.97603981813 402.254051186 -2.52474602067 -9.97703981813 402.254051186 -2.52474602067 -9.97803981813 402.254051186 -2.52474602067 -9.97903981813 402.254051186 -2.52474602067 -9.98003981813 402.254051186 -2.52474602067 -9.98103981813 402.254051186 -2.52474602067 -9.98203981813 402.254051186 -2.52474602067 -9.98303981813 402.254051186 -2.52474602067 -9.98403981813 402.254051186 -2.52474602067 -9.98503981813 402.254051186 -2.52474602067 -9.98603981813 402.254051186 -2.52474602067 -9.98703981813 402.254051186 -2.52474602067 -9.98803981813 402.254051186 -2.52474602067 -9.98903981813 402.254051186 -2.52474602067 -9.99003981813 402.254051186 -2.52474602067 -9.99103981813 402.254051186 -2.52474602067 -9.99203981813 402.254051186 -2.52474602067 -9.99303981813 402.254051186 -2.52474602067 -9.99403981813 402.254051186 -2.52474602067 -9.99503981813 402.254051186 -2.52474602067 -9.99603981813 402.254051186 -2.52474602067 -9.99703981813 402.254051186 -2.52474602067 -9.99803981813 402.254051186 -2.52474602067 -9.99903981813 402.254051186 -2.52474602067 -10.0000398181 402.254051186 -2.52474602067 -10.0010398181 402.254051186 -2.52474602067 -10.0020398181 402.254051186 -2.52474602067 -10.0030398181 402.254051186 -2.52474602067 -10.0040398181 402.254051186 -2.52474602067 -10.0050398181 402.254051186 -2.52474602067 -10.0060398181 402.254051186 -2.52474602067 -10.0070398181 402.254051186 -2.52474602067 -10.0080398181 402.254051186 -2.52474602067 -10.0090398181 402.254051186 -2.52474602067 -10.0100398181 402.254051186 -2.52474602067 -10.0110398181 402.254051186 -2.52474602067 -10.0120398181 402.254051186 -2.52474602067 -10.0130398181 402.254051186 -2.52474602067 -10.0140398181 402.254051186 -2.52474602067 -10.0150398181 402.254051186 -2.52474602067 -10.0160398181 402.254051186 -2.52474602067 -10.0170398181 402.254051186 -2.52474602067 -10.0180398181 402.254051186 -2.52474602067 -10.0190398181 402.254051186 -2.52474602067 -10.0200398181 402.254051186 -2.52474602067 -10.0210398181 402.254051186 -2.52474602067 -10.0220398181 402.254051186 -2.52474602067 -10.0230398181 402.254051186 -2.52474602067 -10.0240398181 402.254051186 -2.52474602067 -10.0250398181 402.254051186 -2.52474602067 -10.0260398181 402.254051186 -2.52474602067 -10.0270398181 402.254051186 -2.52474602067 -10.0280398181 402.254051186 -2.52474602067 -10.0290398181 402.254051186 -2.52474602067 -10.0300398181 402.254051186 -2.52474602067 -10.0310398181 402.254051186 -2.52474602067 -10.0320398181 402.254051186 -2.52474602067 -10.0330398181 402.254051186 -2.52474602067 -10.0340398181 402.254051186 -2.52474602067 -10.0350398181 402.254051186 -2.52474602067 -10.0360398181 402.254051186 -2.52474602067 -10.0370398181 402.254051186 -2.52474602067 -10.0380398181 402.254051186 -2.52474602067 -10.0390398181 402.254051186 -2.52474602067 -10.0400398181 402.254051186 -2.52474602067 -10.0410398181 402.254051186 -2.52474602067 -10.0420398181 402.254051186 -2.52474602067 -10.0430398181 402.254051186 -2.52474602067 -10.0440398181 402.254051186 -2.52474602067 -10.0450398181 402.254051186 -2.52474602067 -10.0460398181 402.254051186 -2.52474602067 -10.0470398181 402.254051186 -2.52474602067 -10.0480398181 402.254051186 -2.52474602067 -10.0490398181 402.254051186 -2.52474602067 -10.0500398181 402.254051186 -2.52474602067 -10.0510398181 402.254051186 -2.52474602067 -10.0520398181 402.254051186 -2.52474602067 -10.0530398181 402.254051186 -2.52474602067 -10.0540398181 402.254051186 -2.52474602067 -10.0550398181 402.254051186 -2.52474602067 -10.0560398181 402.254051186 -2.52474602067 -10.0570398181 402.254051186 -2.52474602067 -10.0580398181 402.254051186 -2.52474602067 -10.0590398181 402.254051186 -2.52474602067 -10.0600398181 402.254051186 -2.52474602067 -10.0610398181 402.254051186 -2.52474602067 -10.0620398181 402.254051186 -2.52474602067 -10.0630398181 402.254051186 -2.52474602067 -10.0640398181 402.254051186 -2.52474602067 -10.0650398181 402.254051186 -2.52474602067 -10.0660398181 402.254051186 -2.52474602067 -10.0670398181 402.254051186 -2.52474602067 -10.0680398181 402.254051186 -2.52474602067 -10.0690398181 402.254051186 -2.52474602067 -10.0700398181 402.254051186 -2.52474602067 -10.0710398181 402.254051186 -2.52474602067 -10.0720398181 402.254051186 -2.52474602067 -10.0730398181 402.254051186 -2.52474602067 -10.0740398181 402.254051186 -2.52474602067 -10.0750398181 402.254051186 -2.52474602067 -10.0760398181 402.254051186 -2.52474602067 -10.0770398181 402.254051186 -2.52474602067 -10.0780398181 402.254051186 -2.52474602067 -10.0790398181 402.254051186 -2.52474602067 -10.0800398181 402.254051186 -2.52474602067 -10.0810398181 402.254051186 -2.52474602067 -10.0820398181 402.254051186 -2.52474602067 -10.0830398181 402.254051186 -2.52474602067 -10.0840398181 402.254051186 -2.52474602067 -10.0850398181 402.254051186 -2.52474602067 -10.0860398181 402.254051186 -2.52474602067 -10.0870398181 402.254051186 -2.52474602067 -10.0880398181 402.254051186 -2.52474602067 -10.0890398181 402.254051186 -2.52474602067 -10.0900398181 402.254051186 -2.52474602067 -10.0910398181 402.254051186 -2.52474602067 -10.0920398181 402.254051186 -2.52474602067 -10.0930398181 402.254051186 -2.52474602067 -10.0940398181 402.254051186 -2.52474602067 -10.0950398181 402.254051186 -2.52474602067 -10.0960398181 402.254051186 -2.52474602067 -10.0970398181 402.254051186 -2.52474602067 -10.0980398181 402.254051186 -2.52474602067 -10.0990398181 402.254051186 -2.52474602067 -10.1000398181 402.254051186 -2.52474602067 -10.1010398181 402.254051186 -2.52474602067 -10.1020398181 402.254051186 -2.52474602067 -10.1030398181 402.254051186 -2.52474602067 -10.1040398181 402.254051186 -2.52474602067 -10.1050398181 402.254051186 -2.52474602067 -10.1060398181 402.254051186 -2.52474602067 -10.1070398181 402.254051186 -2.52474602067 -10.1080398181 402.254051186 -2.52474602067 -10.1090398181 402.254051186 -2.52474602067 -10.1100398181 402.254051186 -2.52474602067 -10.1110398181 402.254051186 -2.52474602067 -10.1120398181 402.254051186 -2.52474602067 -10.1130398181 402.254051186 -2.52474602067 -10.1140398181 402.254051186 -2.52474602067 -10.1150398181 402.254051186 -2.52474602067 -10.1160398181 402.254051186 -2.52474602067 -10.1170398181 402.254051186 -2.52474602067 -10.1180398181 402.254051186 -2.52474602067 -10.1190398181 402.254051186 -2.52474602067 -10.1200398181 402.254051186 -2.52474602067 -10.1210398181 402.254051186 -2.52474602067 -10.1220398181 402.254051186 -2.52474602067 -10.1230398181 402.254051186 -2.52474602067 -10.1240398181 402.254051186 -2.52474602067 -10.1250398181 402.254051186 -2.52474602067 -10.1260398181 402.254051186 -2.52474602067 -10.1270398181 402.254051186 -2.52474602067 -10.1280398181 402.254051186 -2.52474602067 -10.1290398181 402.254051186 -2.52474602067 -10.1300398181 402.254051186 -2.52474602067 -10.1310398181 402.254051186 -2.52474602067 -10.1320398181 402.254051186 -2.52474602067 -10.1330398181 402.254051186 -2.52474602067 -10.1340398181 402.254051186 -2.52474602067 -10.1350398181 402.254051186 -2.52474602067 -10.1360398181 402.254051186 -2.52474602067 -10.1370398181 402.254051186 -2.52474602067 -10.1380398181 402.254051186 -2.52474602067 -10.1390398181 402.254051186 -2.52474602067 -10.1400398181 402.254051186 -2.52474602067 -10.1410398181 402.254051186 -2.52474602067 -10.1420398181 402.254051186 -2.52474602067 -10.1430398181 402.254051186 -2.52474602067 -10.1440398181 402.254051186 -2.52474602067 -10.1450398181 402.254051186 -2.52474602067 -10.1460398181 402.254051186 -2.52474602067 -10.1470398181 402.254051186 -2.52474602067 -10.1480398181 402.254051186 -2.52474602067 -10.1490398181 402.254051186 -2.52474602067 -10.1500398181 402.254051186 -2.52474602067 -10.1510398181 402.254051186 -2.52474602067 -10.1520398181 402.254051186 -2.52474602067 -10.1530398181 402.254051186 -2.52474602067 -10.1540398181 402.254051186 -2.52474602067 -10.1550398181 402.254051186 -2.52474602067 -10.1560398181 402.254051186 -2.52474602067 -10.1570398181 402.254051186 -2.52474602067 -10.1580398181 402.254051186 -2.52474602067 -10.1590398181 402.254051186 -2.52474602067 -10.1600398181 402.254051186 -2.52474602067 -10.1610398181 402.254051186 -2.52474602067 -10.1620398181 402.254051186 -2.52474602067 -10.1630398181 402.254051186 -2.52474602067 -10.1640398181 402.254051186 -2.52474602067 -10.1650398181 402.254051186 -2.52474602067 -10.1660398181 402.254051186 -2.52474602067 -10.1670398181 402.254051186 -2.52474602067 -10.1680398181 402.254051186 -2.52474602067 -10.1690398181 402.254051186 -2.52474602067 -10.1700398181 402.254051186 -2.52474602067 -10.1710398181 402.254051186 -2.52474602067 -10.1720398181 402.254051186 -2.52474602067 -10.1730398181 402.254051186 -2.52474602067 -10.1740398181 402.254051186 -2.52474602067 -10.1750398181 402.254051186 -2.52474602067 -10.1760398181 402.254051186 -2.52474602067 -10.1770398181 402.254051186 -2.52474602067 -10.1780398181 402.254051186 -2.52474602067 -10.1790398181 402.254051186 -2.52474602067 -10.1800398181 402.254051186 -2.52474602067 -10.1810398181 402.254051186 -2.52474602067 -10.1820398181 402.254051186 -2.52474602067 diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_fractstep.csv b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_fractstep.csv deleted file mode 100644 index c0e68d2bef0f..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_fractstep.csv +++ /dev/null @@ -1,3636 +0,0 @@ -time (0.0,0.093) (0.0,0.299) -1e-06 0.0 0.0 -2e-06 0.0 0.0 -3e-06 0.0 0.0 -0.010003 5.86025287745 0.0 -0.020003 26.4141166395 0.0 -0.030003 40.0917737712 0.0 -0.040003 56.7040460929 0.0 -0.050003 68.9039248974 0.0 -0.060003 80.6064265623 0.0 -0.070003 85.0459419421 0.0 -0.080003 88.3516704042 0.0 -0.090003 91.298325576 0.0 -0.100003 94.3316274858 0.0 -0.110003 97.0162669055 0.0 -0.120003 99.6843711937 0.0 -0.130003 100.687132209 0.0 -0.140003 102.028619551 0.0 -0.150003 103.943285732 0.0 -0.160003 106.461834533 0.0 -0.170003 109.542859486 0.0 -0.180003 113.023413922 0.0 -0.190003 116.822936725 0.0 -0.200003 120.90189973 0.0 -0.210003 125.221775633 0.0 -0.220003 129.601565419 0.0 -0.230003 135.502335085 0.0 -0.240003 141.686045957 0.0 -0.250003 146.7060336 0.0 -0.260003 151.248800067 0.0 -0.270003 155.014204763 0.0 -0.280003 158.273456011 0.0 -0.290003 161.168535512 0.0 -0.300003 163.876130935 0.0 -0.310003 166.137969621 0.0 -0.320003 169.677281156 0.0 -0.330003 168.79274762 0.0 -0.340003 167.93743963 0.0 -0.350003 168.263293428 0.0 -0.360003 167.018277557 0.0 -0.370003 168.860494123 0.0 -0.380003 172.279037655 0.0 -0.387916384442 174.982308528 0.0 -0.397916384442 178.265513396 0.0 -0.407916384442 183.387485772 0.0 -0.417916384442 188.094820345 0.0 -0.427916384442 192.651172658 0.0 -0.437916384442 197.231788473 0.0 -0.447916384442 201.895757841 0.0 -0.457916384442 205.545193823 0.0 -0.467916384442 206.612011397 0.0 -0.477916384442 213.108580008 0.0 -0.487916384442 218.47025909 0.0 -0.497916384442 223.796557635 0.0 -0.507916384442 228.884689404 0.0 -0.517916384442 233.693253197 0.0 -0.527916384442 240.089664321 0.0 -0.537916384442 244.592462396 0.0 -0.547916384442 249.140589665 0.0 -0.557916384442 253.15005253 0.0 -0.567916384442 256.848369694 0.0 -0.577916384442 261.178545847 0.0 -0.587916384442 264.683692909 0.0 -0.597916384442 268.048039708 0.0 -0.607916384442 270.561743466 0.0 -0.617916384442 273.012810448 0.0 -0.627916384442 275.017414602 0.0 -0.637916384442 276.64356966 0.0 -0.647916384442 278.983131066 0.0 -0.657916384442 280.446135607 0.0 -0.667916384442 281.687326825 0.0 -0.677916384442 282.710888154 0.0 -0.687916384442 283.535888372 0.0 -0.697916384442 284.188721406 0.0 -0.707916384442 284.636609097 0.0 -0.717916384442 285.017483176 0.0 -0.727916384442 282.039596343 0.0 -0.737916384442 282.76496816 0.0 -0.747916384442 282.481684332 0.0 -0.757916384442 280.093376857 0.0 -0.767916384442 272.860502864 0.0 -0.777916384442 272.78957627 0.0 -0.787916384442 272.575331907 0.0 -0.797916384442 271.352849809 0.0 -0.807916384442 270.363776016 0.0 -0.817916384442 269.46356684 0.0 -0.827916384442 268.601961943 0.0 -0.837916384442 267.72557039 0.0 -0.847916384442 266.704623778 0.0 -0.857916384442 265.438420285 0.0 -0.867916384442 263.734960278 0.0 -0.877916384442 261.956750433 0.0 -0.887916384442 253.678864927 0.0 -0.897916384442 253.419413182 0.0 -0.907916384442 248.854406632 0.0 -0.917916384442 248.470856845 0.0 -0.927916384442 245.030811448 0.0 -0.937916384442 243.160145548 0.0 -0.947916384442 239.77789235 0.0 -0.957916384442 235.301996686 0.0 -0.967916384442 230.584934891 0.0 -0.977916384442 225.796068221 0.0 -0.987916384442 221.663054095 0.0 -0.997916384442 217.608209245 0.0 -1.00791638444 213.619791409 0.0 -1.01791638444 208.986561162 0.0 -1.02791638444 201.563827163 0.0 -1.03791638444 196.231991602 0.0 -1.04791638444 190.084053584 0.0 -1.05791638444 183.019014648 0.0 -1.06791638444 172.89176412 0.0 -1.07791638444 165.607425959 0.0 -1.08791638444 157.153829634 0.0 -1.09791638444 149.808415286 0.0 -1.10791638444 141.835553706 0.0 -1.11791638444 133.64039844 0.0 -1.12791638444 121.88912769 0.0 -1.13791638444 113.280585412 0.0 -1.14791638444 104.170574819 0.0 -1.15791638444 97.073728702 0.0 -1.16791638444 89.0239167014 0.0 -1.17791638444 80.3391157363 0.0 -1.17944511002 68.6404889728 0.0 -1.17994511002 58.3627072506 0.0 -1.18044511002 56.3608857566 0.0 -1.19044511002 50.199784947 0.0 -1.19158187258 49.749149474 0.0 -1.20158187258 45.4629570934 0.0 -1.21158187258 38.7704389673 0.0 -1.22158187258 31.4473594402 0.0 -1.23158187258 23.8541165394 0.0 -1.24158187258 16.611118771 0.0 -1.25158187258 7.61222484998 0.0 -1.26158187258 -1.57344654081 0.0 -1.27158187258 -8.68398712849 0.0 -1.28158187258 -14.6523873971 0.0 -1.29158187258 -26.9647206624 0.0 -1.30158187258 -18.7616774454 0.0 -1.30392612759 0.632044948433 0.0 -1.31392612759 5.53840314034 0.0 -1.32392612759 5.8867818615 0.0 -1.33392612759 -4.47187863069 0.0 -1.34392612759 -15.0824871349 0.0 -1.35392612759 -23.6777689884 0.0 -1.36392612759 0.0 0.0 -1.37392612759 0.0 0.0 -1.38392612759 0.0 0.0 -1.39392612759 0.0 0.0 -1.40392612759 0.0 0.0 -1.41392612759 0.0 0.0 -1.42392612759 0.0 0.0 -1.43392612759 0.0 0.0 -1.4369370496 0.0 0.0 -1.4469370496 0.0 0.0 -1.4569370496 0.0 0.0 -1.4669370496 0.0 0.0 -1.4769370496 0.0 0.0 -1.4869370496 0.0 0.0 -1.4969370496 0.0 0.0 -1.5069370496 0.0 0.0 -1.5169370496 0.0 0.0 -1.5269370496 0.0 0.0 -1.5369370496 0.0 0.0 -1.54624215196 0.0 0.0 -1.55624215196 0.0 0.0 -1.56624215196 0.0 0.0 -1.57624215196 0.0 0.0 -1.58624215196 0.0 0.0 -1.59624215196 0.0 0.0 -1.60624215196 0.0 0.0 -1.61624215196 0.0 0.0 -1.62624215196 0.0 0.0 -1.63624215196 0.0 0.0 -1.64624215196 0.0 0.0 -1.65624215196 0.0 0.0 -1.66624215196 0.0 0.0 -1.67624215196 0.0 0.0 -1.68624215196 0.0 0.0 -1.69624215196 0.0 0.0 -1.70624215196 0.0 0.0 -1.71624215196 0.0 0.0 -1.72624215196 0.0 0.0 -1.73624215196 0.0 0.0 -1.74624215196 0.0 0.0 -1.75624215196 0.0 0.0 -1.76624215196 0.0 0.0 -1.77624215196 0.0 0.0 -1.78624215196 0.0 0.0 -1.79624215196 0.0 0.0 -1.80624215196 0.0 0.0 -1.81624215196 0.0 0.0 -1.82624215196 0.0 0.0 -1.83624215196 0.0 0.0 -1.84624215196 0.0 0.0 -1.85624215196 0.0 0.0 -1.86624215196 0.0 0.0 -1.87624215196 0.0 0.0 -1.88624215196 0.0 0.0 -1.89624215196 0.0 0.0 -1.90624215196 0.0 0.0 -1.91624215196 0.0 0.0 -1.92624215196 0.0 0.0 -1.93624215196 0.0 0.0 -1.94624215196 0.0 0.0 -1.95624215196 0.0 0.0 -1.96624215196 0.0 0.0 -1.97537975903 0.0 0.0 -1.98537975903 0.0 0.0 -1.99537975903 0.0 0.0 -2.00537975903 0.0 0.0 -2.01537975903 0.0 0.0 -2.02537975903 0.0 0.0 -2.03537975903 0.0 0.0 -2.04537975903 0.0 0.0 -2.05537975903 0.0 0.0 -2.06537975903 0.0 0.0 -2.07537975903 0.0 0.0 -2.08537975903 0.0 0.0 -2.09537975903 0.0 0.0 -2.10537975903 0.0 0.0 -2.11537975903 0.0 0.0 -2.12537975903 0.0 0.0 -2.13537975903 0.0 0.0 -2.14537975903 0.0 0.0 -2.15537975903 0.0 0.0 -2.16537975903 0.0 0.0 -2.17410600246 0.0 0.0 -2.18410600246 0.0 0.0 -2.19410600246 0.0 0.0 -2.20058545601 0.0 0.0 -2.21058545601 0.0 0.0 -2.21863994086 0.0 0.0 -2.22430574384 0.0 0.0 -2.22732534965 0.0 0.0 -2.23732534965 0.0 0.0 -2.24732534965 0.0 0.0 -2.25732534965 0.0 0.0 -2.26732534965 0.0 0.0 -2.27732534965 0.0 0.0 -2.28732534965 0.0 0.0 -2.29732534965 0.0 0.0 -2.30732534965 0.0 0.0 -2.312960813 0.0 0.0 -2.31629282831 0.0 0.0 -2.32033682908 0.0 0.0 -2.33033682908 0.0 0.0 -2.34033682908 -7.77906336743 0.0 -2.35033682908 36.367653034 0.0 -2.36033682908 97.4076978108 0.0 -2.37033682908 167.177907557 0.0 -2.38033682908 250.37866477 0.0 -2.39033682908 339.679605116 0.0 -2.40033682908 438.443075511 0.0 -2.41033682908 534.201180136 0.0 -2.42033682908 628.8714576 0.0 -2.43033682908 705.882172185 0.0 -2.44033682908 787.059711651 0.0 -2.44083682908 1175.24126877 0.0 -2.44133682908 1374.78930999 0.0 -2.44183682908 1453.41030909 0.0 -2.44335407233 1497.97391547 0.0 -2.45265856786 1486.27067592 0.0 -2.45632187331 1343.59904478 0.0 -2.46100991741 1217.52810452 0.0 -2.46505225869 1038.33314969 0.0 -2.46943749378 874.302455661 0.0 -2.47865556356 779.851972334 0.0 -2.48190197326 518.814655578 0.0 -2.48667094722 382.840964725 0.0 -2.49207204455 305.518930994 0.0 -2.50207204455 317.212609216 0.0 -2.50625414378 291.414229081 0.0 -2.50810932947 258.548431828 0.0 -2.51810932947 287.462933068 0.0 -2.5243280577 348.605387079 0.0 -2.5343280577 407.572659474 0.0 -2.5443280577 488.466599399 0.0 -2.5543280577 578.14261195 0.0 -2.5643280577 666.249214714 0.0 -2.5743280577 753.170650463 0.0 -2.5843280577 821.6253612 0.0 -2.5943280577 882.766698429 0.0 -2.6043280577 936.040724831 0.0 -2.6143280577 971.890673867 0.0 -2.6243280577 991.533573075 0.0 -2.6343280577 995.82283903 0.0 -2.6443280577 985.679657182 0.0 -2.6543280577 962.513663925 0.0 -2.6643280577 935.812919274 0.0 -2.6743280577 900.932121625 0.0 -2.6843280577 862.738886154 0.0 -2.6943280577 828.374923538 0.0 -2.7043280577 797.1262688 0.0 -2.7143280577 765.338554385 0.0 -2.7243280577 736.273893869 0.0 -2.7343280577 719.472566431 0.0 -2.7443280577 693.992353623 0.0 -2.7543280577 673.181818862 0.0 -2.7643280577 654.955686796 0.0 -2.76817403181 645.572529976 0.0 -2.77817403181 629.935275207 0.0 -2.78363517832 618.449997792 0.0 -2.79363517832 602.030862668 0.0 -2.80363517832 579.867229796 0.0 -2.81363517832 551.827075314 0.0 -2.81886172895 530.344977785 0.0 -2.82886172895 503.835298144 0.0 -2.83886172895 475.286474109 0.0 -2.84886172895 443.814380036 0.0 -2.85392266577 419.907792413 0.0 -2.85657464275 398.266601537 0.0 -2.85892615486 381.824894946 0.0 -2.86892615486 360.585057781 0.0 -2.87892615486 338.901451616 0.0 -2.88892615486 322.537988501 0.0 -2.89892615486 308.971984165 0.0 -2.90892615486 298.415722515 0.0 -2.91892615486 289.703513291 0.0 -2.92448810458 291.449322095 0.0 -2.93448810458 281.467703584 0.0 -2.94448810458 273.583348662 0.0 -2.95448810458 265.420833509 0.0 -2.96448810458 258.288244257 0.0 -2.97028570777 257.474865834 0.0 -2.97078570777 299.327446866 0.0 -2.98068103619 281.153125107 0.0 -2.98970497366 270.660141384 0.0 -2.99664658698 263.545318983 0.0 -3.00664658698 250.233787718 0.0 -3.01474371334 237.819635735 0.0 -3.01729456537 230.049083562 0.0 -3.0267558255 223.423419181 0.0 -3.02959943616 213.756722451 0.0 -3.03881677494 205.921582466 0.0 -3.04332083708 204.935962078 0.0 -3.04988285608 198.765755377 0.0 -3.05922874861 190.250161789 0.0 -3.06922874861 182.858242267 0.0 -3.07922874861 175.500291621 0.0 -3.08228839742 177.511005707 0.0 -3.09228839742 167.669565802 0.0 -3.0980528882 163.02557502 0.0 -3.10069622263 158.516485932 0.0 -3.110398609 149.996915249 0.0 -3.120398609 143.835658432 0.0 -3.12814089095 140.804825042 0.0 -3.13225390307 144.309455812 0.0 -3.13651143086 140.13174194 0.0 -3.13822563197 142.271887318 0.0 -3.14014801864 142.292767323 0.0 -3.14275953478 140.491033719 0.0 -3.14574934421 136.738674403 0.0 -3.14778467066 133.853363188 0.0 -3.15283530155 130.732522302 0.0 -3.15674163464 116.912045279 0.0 -3.16115722299 109.969064776 0.0 -3.16486760614 105.233152075 0.0 -3.16859208839 97.46149837 0.0 -3.17189287544 108.603908399 0.0 -3.17414780095 113.044797451 0.0 -3.17810843863 110.238990988 0.0 -3.17875856514 108.68613355 0.0 -3.18062224419 107.016132024 0.0 -3.18127150173 104.329546861 0.0 -3.18177150173 101.998682032 0.0 -3.18227150173 100.739189275 0.0 -3.18277150173 97.6846051906 0.0 -3.18345428164 95.7949902836 0.0 -3.18573428564 92.8529815609 0.0 -3.18753926714 91.377013415 0.0 -3.19309593606 85.1601851872 0.0 -3.19968229261 78.7333325911 0.0 -3.20388212681 76.3566963516 0.0 -3.2080190645 71.876195164 0.0 -3.21281212212 68.1248216708 0.0 -3.21676376625 70.4366425992 0.0 -3.21953853772 63.5433531753 0.0 -3.22150117018 66.1628543689 0.0 -3.22500503986 63.1275687802 0.0 -3.22646119779 58.0684326036 0.0 -3.22974295297 51.8274477631 0.0 -3.23152123397 46.2596420907 0.0 -3.234020097 42.6106975741 0.0 -3.23588659182 38.6092674969 0.0 -3.24118528641 37.0829401571 0.0 -3.24791810508 29.4872329878 0.0 -3.25060733932 25.5992144344 0.0 -3.2564512452 15.5230046965 0.0 -3.25987137639 -1.35420898101 0.0 -3.26588936786 -13.334420419 0.0 -3.27239568464 -29.9887129627 0.0 -3.2787044316 -44.1834720086 0.0 -3.28290688405 -55.4647726603 0.0 -3.28426406889 -67.0385533 0.0 -3.28617698712 -63.387210643 0.0 -3.28731928374 -60.2571258678 0.0 -3.28888562177 -63.2434980544 0.0 -3.29197618952 -68.6533356381 0.0 -3.29563750231 -77.2161556365 0.0 -3.29780800542 0.0 0.0 -3.30127318655 0.0 0.0 -3.30456632198 0.0 0.0 -3.30670395722 0.0 0.0 -3.31000948538 0.0 0.0 -3.3127355701 0.0 0.0 -3.3171837683 0.0 0.0 -3.32011586586 0.0 0.0 -3.32646423376 0.0 0.0 -3.33153490823 0.0 0.0 -3.3363059489 0.0 0.0 -3.34193638315 0.0 0.0 -3.34614689611 0.0 0.0 -3.35285050228 0.0 0.0 -3.35814414477 0.0 0.0 -3.364409169 0.0 0.0 -3.36781364554 0.0 0.0 -3.3747211083 0.0 0.0 -3.38246642779 0.0 0.0 -3.3883809406 0.0 0.0 -3.39345154673 0.0 0.0 -3.40184887361 0.0 0.0 -3.41038251712 0.0 0.0 -3.4188885344 0.0 0.0 -3.4288885344 0.0 0.0 -3.4388885344 0.0 0.0 -3.4488885344 0.0 0.0 -3.4588885344 0.0 0.0 -3.4688885344 0.0 0.0 -3.4788885344 0.0 0.0 -3.48550902817 0.0 0.0 -3.49550902817 0.0 0.0 -3.50550902817 0.0 0.0 -3.51428207127 0.0 0.0 -3.52353981121 0.0 0.0 -3.53353981121 0.0 0.0 -3.54304658949 0.0 0.0 -3.54782820235 0.0 0.0 -3.55712484758 0.0 0.0 -3.55995972789 0.0 0.0 -3.56762938977 0.0 0.0 -3.5752112338 0.0 0.0 -3.5831199338 0.0 0.0 -3.59005634974 0.0 0.0 -3.5967845582 0.0 0.0 -3.60206696113 0.0 0.0 -3.60679832204 0.0 0.0 -3.6119262882 0.0 0.0 -3.61627980294 0.0 0.0 -3.62115754262 0.0 0.0 -3.62586915542 0.0 0.0 -3.63039236565 0.0 0.0 -3.63431556282 0.0 0.0 -3.63834990689 0.0 0.0 -3.641999197 0.0 0.0 -3.64718790831 0.0 0.0 -3.65038505931 0.0 0.0 -3.6520591679 0.0 0.0 -3.65731989305 0.0 0.0 -3.66187387115 0.0 0.0 -3.66632081992 0.0 0.0 -3.67033477706 0.0 0.0 -3.67612131714 0.0 0.0 -3.68031405979 0.0 0.0 -3.68415841864 0.0 0.0 -3.68847994095 0.0 0.0 -3.69276461684 0.0 0.0 -3.69745621572 0.0 0.0 -3.70317035968 0.0 0.0 -3.70844197839 0.0 0.0 -3.71451778141 0.0 0.0 -3.72023867602 0.0 0.0 -3.72423681448 0.0 0.0 -3.72977498031 0.0 0.0 -3.7349986949 0.0 0.0 -3.73902577267 0.0 0.0 -3.74391103874 0.0 0.0 -3.74827988099 0.0 0.0 -3.75047628368 0.0 0.0 -3.75266752123 0.0 0.0 -3.75435433082 0.0 0.0 -3.75623906595 0.0 0.0 -3.75877675636 0.0 0.0 -3.76186470778 0.0 0.0 -3.76613328955 0.0 0.0 -3.77024467394 0.0 0.0 -3.77095349785 0.0 0.0 -3.77503722342 0.0 0.0 -3.77683747142 0.0 0.0 -3.77733747142 0.0 0.0 -3.77783747142 0.0 0.0 -3.77847749009 0.0 0.0 -3.77982798597 0.0 0.0 -3.78241284289 0.0 0.0 -3.78616229417 0.0 0.0 -3.78985109991 0.0 0.0 -3.79345449739 0.0 0.0 -3.79699933991 0.0 0.0 -3.7993415874 0.0 0.0 -3.80079891906 0.0 0.0 -3.80390035481 0.0 0.0 -3.80499583571 0.0 0.0 -3.8067733592 0.0 0.0 -3.80996878477 0.0 0.0 -3.81328185237 0.0 0.0 -3.81651381906 0.0 0.0 -3.81812984093 0.0 0.0 -3.82116250621 0.0 0.0 -3.82264591063 0.0 0.0 -3.82362001696 0.0 0.0 -3.82682628775 0.0 0.0 -3.82996109077 0.0 0.0 -3.83308069083 0.0 0.0 -3.83613433796 0.0 0.0 -3.8386848624 0.0 0.0 -3.84158161315 0.0 0.0 -3.84444581976 0.0 0.0 -3.84730257423 0.0 0.0 -3.85004736365 0.0 0.0 -3.85243816316 0.0 0.0 -3.85485932748 0.0 0.0 -3.85809518031 0.0 0.0 -3.86050155419 0.0 0.0 -3.86510596286 0.0 0.0 -3.87102998525 0.0 0.0 -3.87372743509 0.0 0.0 -3.88034945633 0.0 0.0 -3.88661266052 0.0 0.0 -3.89555212031 0.0 0.0 -3.905403127 0.0 0.0 -3.90663999353 0.0 0.0 -3.90855461106 0.0 0.0 -3.90926684699 0.0 0.0 -3.91926684699 0.0 0.0 -3.92926684699 0.0 0.0 -3.93108960904 0.0 0.0 -3.94108960904 0.0 0.0 -3.95033876754 0.0 0.0 -3.9602762132 0.0 0.0 -3.9702762132 0.0 0.0 -3.97462807695 0.0 0.0 -3.97964336485 0.0 0.0 -3.98061814601 0.0 0.0 -3.989376315 0.0 0.0 -3.99251457939 0.0 0.0 -3.99343752017 0.0 0.0 -3.99933101813 0.0 0.0 -4.00548362024 0.0 0.0 -4.01201660494 0.0 0.0 -4.01727128352 0.0 0.0 -4.02636440549 0.0 0.0 -4.03508238197 0.0 0.0 -4.03938971748 0.0 0.0 -4.04393496123 0.0 0.0 -4.04732038687 0.0 0.0 -4.05031997427 0.0 0.0 -4.05323537215 0.0 0.0 -4.05679154147 0.0 0.0 -4.05999674009 0.0 0.0 -4.06288748749 0.0 0.0 -4.06758810414 0.0 0.0 -4.07262100348 0.0 0.0 -4.07778373096 0.0 0.0 -4.08360373067 0.0 0.0 -4.08751370662 0.0 0.0 -4.09236196009 0.0 0.0 -4.09877627345 0.0 0.0 -4.10349479062 0.0 0.0 -4.10814658002 0.0 0.0 -4.11442521973 0.0 0.0 -4.11890372144 0.0 0.0 -4.12430053869 0.0 0.0 -4.12955603135 0.0 0.0 -4.13520909658 0.0 0.0 -4.13980788768 0.0 0.0 -4.14051262063 0.0 0.0 -4.14403433145 0.0 0.0 -4.14702584613 0.0 0.0 -4.15294155998 0.0 0.0 -4.15991347486 0.0 0.0 -4.16829890381 72.8814228517 0.0 -4.17006292487 1303.18668458 0.0 -4.17464109005 1837.3180802 0.0 -4.17905612574 0.0 0.0 -4.18502150886 0.0 0.0 -4.19107546249 0.0 0.0 -4.19384953309 2314.28214746 0.0 -4.19904547087 0.0 0.0 -4.20284271986 1414.59824787 0.0 -4.20520627607 1683.59968371 0.0 -4.20739609371 1696.99292238 0.0 -4.21321039042 2098.40790273 0.0 -4.21630703943 2167.31499716 0.0 -4.22027017482 2476.57523367 0.0 -4.22132572652 2915.11234097 0.0 -4.22617802344 2573.97233853 0.0 -4.23109515653 2285.98503301 0.0 -4.23495202768 1783.90269425 0.0 -4.2401259718 1365.09417304 0.0 -4.24574162298 922.959861592 0.0 -4.24699144793 -397.38994901 0.0 -4.24985797875 -719.748172482 0.0 -4.25636464162 -669.345063984 0.0 -4.26423765215 -466.837293532 0.0 -4.27231611751 -154.850488188 0.0 -4.28051512504 225.528186009 0.0 -4.28391474558 732.657098679 0.0 -4.28971604943 916.046167848 0.0 -4.29618534835 993.650139561 0.0 -4.29954264273 1073.9602337 0.0 -4.30467176019 1042.12757527 0.0 -4.31467176019 935.112288295 3.22421793295 -4.31979777894 797.461609973 3.57342952946 -4.32979777894 693.097433731 2.12801975871 -4.33962817048 597.939611771 0.0 -4.34505770441 498.280909989 0.0 -4.35010333003 433.605683486 0.0 -4.36010333003 441.209444519 0.0 -4.36966481166 468.061609544 0.0 -4.37700180299 495.207665003 0.0 -4.38203317327 517.205033821 0.0 -4.38749678386 533.736030538 0.0 -4.39389184914 554.226890351 0.0 -4.40123732483 574.891366924 0.0 -4.4096807382 594.82112813 13.5883375058 -4.41733093207 602.528089191 12.1826810565 -4.42567781994 600.826609546 9.50563438701 -4.43457876998 600.237953339 10.2085067372 -4.43947829811 586.993620317 15.2133632235 -4.44520930611 577.521587994 13.6320012925 -4.45520930611 581.174448381 12.92837283 -4.46012632675 599.497394613 10.3045330501 -4.46517513728 617.073174871 14.4017358591 -4.4685162482 644.763128576 11.8276661968 -4.4785162482 663.216509705 10.321101055 -4.48422179999 695.503408883 10.6488392941 -4.49422179999 723.71049744 0.0 -4.50310619655 752.72827817 0.0 -4.51109239785 786.719065172 0.0 -4.51857518675 812.420612206 0.0 -4.52568016142 831.853527902 0.0 -4.53134222553 883.68564471 0.0 -4.53711536781 890.401580711 0.670627524828 -4.54395008386 897.840082252 0.545687169379 -4.54921267531 915.826637545 0.482918236993 -4.55525948465 972.286229628 0.0 -4.56063211863 958.793295682 0.0 -4.56778087349 985.799916585 0.344329520476 -4.57611264159 965.71298482 0.125680435255 -4.57708552056 1046.58086099 1.06555041852 -4.58436577012 1000.79541745 0.0 -4.58615216033 953.577501094 0.0 -4.59169618502 932.379129563 0.0 -4.59836332457 924.807479017 0.0 -4.60031977638 886.177645557 0.0 -4.6035116311 863.253160381 0.0 -4.61086971308 845.376817294 0.0 -4.61796865833 815.438501991 0.0 -4.62482574974 785.087853245 0.0 -4.63158276312 757.76684792 0.0 -4.63789942725 728.71481215 0.0 -4.6431804473 691.903384431 0.0 -4.64962104997 694.587074076 0.0 -4.65317186624 643.719387897 0.0 -4.65937904326 606.84439222 0.0 -4.65987904326 868.282189891 0.0 -4.66037904326 817.212002802 0.0 -4.66095902682 744.733358409 0.0 -4.66211457033 730.726420921 0.0 -4.66440388365 844.927804628 0.0 -4.66900638384 781.740924453 0.0 -4.67296371879 668.300972349 0.0 -4.67951958259 595.196860537 0.0 -4.68745202157 480.288120982 0.0 -4.69277653194 378.742149302 0.0 -4.69474680231 200.982828018 0.0 -4.70124020711 184.826418028 0.0 -4.70828465484 170.532409344 0.0 -4.71610541992 240.448164685 0.0 -4.72067683857 184.157701293 0.0 -4.72725064013 110.70364078 0.0 -4.73532473445 137.312299898 0.0 -4.74395734858 145.915182288 0.0 -4.75305911195 150.462746945 0.0 -4.76305911195 147.364493871 0.0 -4.7694423307 167.777609837 0.0 -4.77549078388 193.669407768 0.0 -4.77902575954 219.337361102 0.0 -4.78873457532 225.203038979 0.0 -4.79795495231 244.911822974 0.0 -4.80647701587 272.014428399 0.0 -4.80946871588 366.971700046 0.0 -4.81218829356 413.705042796 0.0 -4.81471669798 438.453566236 0.0 -4.82119424337 400.496013486 0.0 -4.82966971817 413.147431369 0.0 -4.83501249886 437.272487809 0.0 -4.84501249886 433.145726151 0.0 -4.84700119116 464.607899398 0.0 -4.85642127723 438.55819879 0.0 -4.86196949532 417.220569083 0.0 -4.87013119216 394.692264735 0.0 -4.87732901102 373.059853523 0.0 -4.88636642394 353.055842132 0.0 -4.88686642394 95.2162452136 0.0 -4.88736642394 -48.0809789655 0.0 -4.88786642394 -171.422036304 0.0 -4.88920211331 -194.289043155 0.0 -4.89143110271 -196.044375786 0.0 -4.89527924751 -172.32989784 0.0 -4.90079841717 -121.751434395 0.0 -4.9077850998 -21.5367859333 0.0 -4.91479615057 85.5080533669 0.0 -4.91893089151 263.153407926 0.0 -4.92489291749 387.444527112 0.0 -4.93030052409 487.905553054 0.0 -4.93563333689 564.646154053 0.0 -4.94198727645 618.632107236 0.0 -4.94993818386 615.410629656 0.0 -4.95438284826 596.944916363 0.0 -4.96277550134 559.610564573 0.0 -4.97142557563 473.287221471 0.0 -4.97465822709 323.349199262 0.0 -4.97927212412 254.665505938 0.0 -4.98194773892 147.587931765 0.0 -4.98560167689 79.4497068873 0.0 -4.98934145939 46.2728982084 0.0 -4.993142044 16.3579882424 0.0 -4.99711185683 4.99286272603 0.0 -5.00177256854 6.27107310402 0.0 -5.00591741433 23.614170986 0.0 -5.00910319456 40.3940318601 0.0 -5.01240664205 58.8804567839 0.0 -5.01786241204 81.5282021768 0.0 -5.02415850507 120.701521089 0.0 -5.02858781041 168.650840356 0.0 -5.03315929033 196.377439555 0.0 -5.03735799837 218.810763812 0.0 -5.04102718756 265.30954646 0.0 -5.04201542367 366.013773545 0.0 -5.04821943254 339.881718026 0.0 -5.05523733426 309.587234216 0.0 -5.06143344334 276.472573202 0.0 -5.06523355939 240.989439973 0.0 -5.07221064631 211.044924481 0.0 -5.07883159341 181.67583348 0.0 -5.08390854471 136.103799857 0.0 -5.08706631401 96.5665619777 0.0 -5.09029964922 73.6108374757 0.0 -5.09392218867 60.7576871604 0.0 -5.09791122514 59.7990890523 0.0 -5.10353334403 49.2891060294 0.0 -5.10782211364 45.35934829 0.0 -5.11350122125 55.7020100258 0.0 -5.11934191393 54.2776047174 0.0 -5.12065657402 70.5879666231 0.0 -5.12266672988 87.7103233599 0.0 -5.12533714164 94.6245229656 0.0 -5.12866424378 84.0807189899 0.0 -5.13222112888 63.6402233607 0.0 -5.13678069664 54.1714456008 0.0 -5.13728069664 24.3524729691 0.0 -5.13778069664 32.7085780557 0.0 -5.13828069664 47.7523702226 0.0 -5.13878069664 65.8300397441 0.0 -5.1438889722 65.696725692 0.0 -5.14568449269 66.3508105972 0.0 -5.14682249726 61.1905001171 0.0 -5.14918568195 47.3645586075 0.0 -5.15265237375 26.8876342462 0.0 -5.15718863099 16.3478003893 0.0 -5.15883190653 -4.69622911467 0.0 -5.16298899885 -15.3555143516 0.0 -5.1644260617 -13.9765011429 0.0 -5.17124083325 -13.5250074818 0.0 -5.17712239638 -12.826088161 0.0 -5.18175294935 -17.3971500425 0.0 -5.18777899485 -21.3033895604 0.0 -5.19117755875 -15.4636051037 0.0 -5.19383870808 -8.38454888793 0.0 -5.19801010486 -11.1870671403 0.0 -5.20218515922 -16.0497758433 0.0 -5.2050333646 0.0 0.0 -5.2078516774 0.0 0.0 -5.21213080648 0.0 0.0 -5.21521993691 0.0 0.0 -5.21868391253 0.0 0.0 -5.22615710512 0.0 0.0 -5.22933416766 0.0 0.0 -5.23560405981 0.0 0.0 -5.24311108097 0.0 0.0 -5.24947973092 0.0 0.0 -5.25592815682 0.0 0.0 -5.26265537088 0.0 0.0 -5.26932080741 0.0 0.0 -5.27623887713 0.0 0.0 -5.28238167812 0.0 0.0 -5.28906859234 0.0 0.0 -5.29656439393 0.0 0.0 -5.30548922163 0.0 0.0 -5.31461420351 0.0 0.0 -5.32461420351 0.0 0.0 -5.33298758673 0.0 0.0 -5.34298758673 0.0 0.0 -5.35298758673 0.0 0.0 -5.36288137172 0.0 0.0 -5.37288137172 0.0 0.0 -5.38288137172 0.0 0.0 -5.39276050558 0.0 0.0 -5.39892039443 0.0 0.0 -5.40892039443 0.0 0.0 -5.41892039443 0.0 0.0 -5.42505628448 0.0 0.0 -5.42810699525 0.0 0.0 -5.43810699525 0.0 0.0 -5.44810699525 0.0 0.0 -5.45810699525 0.0 0.0 -5.46810699525 0.0 0.0 -5.47634031114 0.0 0.0 -5.48478236958 0.0 0.0 -5.49318414388 0.0 0.0 -5.50119306381 0.0 0.0 -5.50855298188 0.0 0.0 -5.51247457228 0.0 0.0 -5.51350915638 0.0 0.0 -5.52081826036 0.0 0.0 -5.52615875348 0.0 0.0 -5.53219541879 0.0 0.0 -5.53804439962 0.0 0.0 -5.54434498706 0.0 0.0 -5.54823011771 0.0 0.0 -5.5521430739 0.0 0.0 -5.55762203172 0.0 0.0 -5.56293857854 0.0 0.0 -5.56702696663 0.0 0.0 -5.5710229639 0.0 0.0 -5.57505870021 0.0 0.0 -5.57908893124 0.0 0.0 -5.58294480837 0.0 0.0 -5.58765320286 0.0 0.0 -5.59223111419 0.0 0.0 -5.59647860811 0.0 0.0 -5.59991900318 0.0 0.0 -5.60323079124 0.0 0.0 -5.60639281041 0.0 0.0 -5.61025287022 0.0 0.0 -5.61536252757 0.0 0.0 -5.62158081399 0.0 0.0 -5.62756358708 0.0 0.0 -5.63286783439 0.0 0.0 -5.63803968498 0.0 0.0 -5.64338008481 0.0 0.0 -5.64718437875 0.0 0.0 -5.64949203489 0.0 0.0 -5.65411837721 0.0 0.0 -5.65735859908 0.0 0.0 -5.65785859908 0.0 0.0 -5.65835859908 0.0 0.0 -5.65916927432 0.0 0.0 -5.66074903338 0.0 0.0 -5.66387077946 0.0 0.0 -5.6679633465 0.0 0.0 -5.67221690397 0.0 0.0 -5.67651776997 0.0 0.0 -5.6807572941 0.0 0.0 -5.68770082555 0.0 0.0 -5.6928416943 0.0 0.0 -5.69590076239 0.0 0.0 -5.69779870992 0.0 0.0 -5.70288864278 0.0 0.0 -5.70911983948 0.0 0.0 -5.71423841142 0.0 0.0 -5.72423841142 0.0 0.0 -5.72473841142 0.0 0.0 -5.72531041878 0.0 0.0 -5.73333789795 0.0 0.0 -5.7369756743 0.0 0.0 -5.74207430199 0.0 0.0 -5.74460098869 0.0 0.0 -5.74784706189 0.0 0.0 -5.75209671588 0.0 0.0 -5.75776055612 0.0 0.0 -5.76401375811 0.0 0.0 -5.77005626657 0.0 0.0 -5.77387103065 0.0 0.0 -5.78041554103 0.0 0.0 -5.78723320054 0.0 0.0 -5.79323917047 0.0 0.0 -5.80164378279 0.0 0.0 -5.80826088234 0.0 0.0 -5.81730355019 0.0 0.0 -5.82630055744 0.0 0.0 -5.83500700504 0.0 0.0 -5.83570844105 0.0 0.0 -5.83656595874 0.0 0.0 -5.83806967766 0.0 0.0 -5.84806967766 0.0 0.0 -5.85336917523 0.0 0.0 -5.86204544814 0.0 0.0 -5.87204544814 0.0 0.0 -5.87505398618 0.0 0.0 -5.88351187899 0.0 0.0 -5.89058029808 0.0 0.0 -5.89200510165 0.0 0.0 -5.89310390822 0.0 0.0 -5.90269868129 0.0 0.0 -5.90616367995 0.0 0.0 -5.91115938927 0.0 0.0 -5.92115938927 0.0 0.0 -5.92957944546 0.0 0.0 -5.93451240776 0.0 0.0 -5.93649421638 0.0 0.0 -5.94270085228 0.0 0.0 -5.95026788224 0.0 0.0 -5.95843969183 0.0 0.0 -5.96454016185 0.0 0.0 -5.96545156536 0.0 0.0 -5.97425756521 0.0 0.0 -5.97560343293 0.0 0.0 -5.98137970626 0.0 0.0 -5.98321643558 0.0 0.0 -5.98986395396 0.0 0.0 -5.99089826085 0.0 0.0 -5.99141631077 0.0 0.0 -5.9984430716 0.0 0.0 -6.00260338984 0.0 0.0 -6.00912388177 0.0 0.0 -6.01745189546 0.0 0.0 -6.0252977524 0.0 0.0 -6.03293856681 0.0 0.0 -6.03926815443 0.0 0.0 -6.04433010776 0.0 0.0 -6.04718075894 0.0 0.0 -6.05003223092 0.0 0.0 -6.05286377047 0.0 0.0 -6.05480656549 0.0 0.0 -6.05737133235 0.0 0.0 -6.06130598127 0.0 0.0 -6.06558637405 0.0 0.0 -6.06741917843 0.0 0.0 -6.06976126516 0.0 0.0 -6.0724491222 0.0 0.0 -6.07523361871 0.0 0.0 -6.07933137748 0.0 0.0 -6.08181991112 0.0 0.0 -6.08524029734 0.0 0.0 -6.08899171433 0.0 0.0 -6.091323065 0.0 0.0 -6.09259927311 2480.50253267 0.0 -6.09567740927 1894.99645111 0.0 -6.09988574452 1214.77598853 0.0 -6.10385162932 2286.57106577 0.0 -6.10691020991 1991.15452191 0.0 -6.11194994569 2566.47058288 0.0 -6.11481026569 2784.05314562 0.0 -6.11860185714 2523.07937242 0.0 -6.12301880428 2257.40174339 0.0 -6.12351880428 1375.66112669 0.0 -6.12471291007 1329.24018539 0.0 -6.12559877232 1304.85840442 0.0 -6.12723487583 1298.68960157 0.0 -6.13001388629 1290.14090018 0.0 -6.13126784625 1348.85615944 0.0 -6.1329936054 1416.43142109 0.0 -6.13452028238 1355.94520236 0.0 -6.1364627166 1299.85400773 0.0 -6.13852069313 1291.25569977 0.0 -6.1410016477 1258.22813821 0.0 -6.14340663402 1205.63195792 0.0 -6.14544272425 1142.04033014 0.0 -6.1475184496 1076.88105597 0.0 -6.1496324297 1053.24587969 0.0 -6.15176550659 959.577202037 0.0 -6.15408203908 880.4119865 0.0 -6.15622410684 772.618478992 0.0 -6.15838371951 698.141299993 0.0 -6.16056777198 627.654985171 0.0 -6.1627649724 554.024981696 0.0 -6.16507700795 541.292030057 0.0 -6.16732991396 484.981389826 0.0 -6.16960526803 472.926178042 1.61605465712 -6.17185237322 477.338007327 0.936167081562 -6.17411471834 482.974207924 0.0 -6.17643973498 493.783744689 0.0 -6.17877541133 529.19150243 0.0 -6.18123815945 574.316030945 0.0 -6.18356622616 619.445792547 0.0 -6.18591123257 658.711282495 0.0 -6.18831670896 704.309890148 0.0 -6.19073413796 744.351270584 0.0 -6.19332515911 773.748505899 0.0 -6.19574351786 799.971071668 0.0 -6.19818105109 808.43545982 0.0 -6.20067734034 803.997723647 0.0 -6.20318733466 787.130741394 0.0 -6.20592627274 755.868889127 0.0 -6.2084467303 722.974107687 0.0 -6.21098894724 685.029258729 0.0 -6.213590848 630.962331906 0.0 -6.21620853107 579.321907527 -2.61500746226 -6.21907733752 530.345184677 -0.259528350856 -6.22171426317 481.758011206 0.982245413556 -6.22437744836 443.985038286 2.19098487468 -6.22709091617 412.106885427 -17.097300454 -6.22982382253 400.000886018 0.0 -6.23274545106 399.809047758 0.0 -6.23553765921 416.867233636 0.0 -6.23784492196 432.244990122 0.0 -6.24105397226 453.446250708 0.0 -6.24781063659 490.51044942 0.0 -6.25781063659 531.586335425 0.0 -6.26781063659 563.224690037 0.0 -6.27781063659 599.007850548 0.0 -6.28781063659 624.005856703 4.42207936921 -6.2949101231 639.364654062 5.91086262358 -6.30317677538 652.269371955 2.7955027488 -6.31161988795 669.042741434 4.60194500184 -6.32157679826 680.784470454 1.18782897118 -6.33157679826 688.630592288 0.0 -6.34157679826 688.255369163 12.2755754892 -6.35157679826 696.854739433 13.4048362518 -6.36120383772 703.436655818 14.9990629416 -6.37005376 710.789968506 20.1750769539 -6.37643805861 712.180351663 16.1820581718 -6.38554449006 722.855722335 10.1474798971 -6.39381723145 737.460528611 4.86076162734 -6.40159405695 760.784559351 5.92943529071 -6.40907296012 788.661362117 1.27784588146 -6.41632015497 819.283285068 -2.49230261898 -6.42331677165 851.074055816 0.0 -6.42985096728 883.412268831 0.0 -6.43606377708 913.232323863 0.0 -6.43743741298 1028.24404696 0.0 -6.44269036473 1048.61978415 0.518065371365 -6.44396554948 1110.73317357 0.809295302935 -6.4476873219 1111.2572453 0.481591285596 -6.4488325182 1121.03862673 0.708073072119 -6.4535238915 1109.62284576 0.48890415557 -6.4580170111 1098.23156524 0.0 -6.46244363151 1066.92530887 0.0 -6.46683086483 1022.51367196 0.0 -6.47161159021 973.550850183 0.0 -6.47483661375 905.662620615 0.0 -6.47957308928 855.884303151 0.214537992366 -6.48334465885 802.627389749 0.130338518805 -6.48835621937 765.018689849 0.0394175157298 -6.49315461146 727.401988032 0.0 -6.49791478205 699.187376095 0.0 -6.50240871993 707.064969969 0.0 -6.506752808 755.541802963 0.0 -6.50837504356 807.022778544 0.0 -6.51043778106 829.654346336 0.0 -6.51495020998 857.286002266 0.0 -6.51894814662 887.833041345 0.0 -6.522838932 945.766537267 0.0 -6.52686572965 1041.13435796 0.0 -6.52932891365 1122.56877307 0.0 -6.53017038862 1262.35214381 0.0 -6.53199260652 1273.86555997 0.0 -6.5335839789 1334.11075939 0.0 -6.53714285713 1289.26645345 0.0 -6.5406585101 1229.65276015 0.0 -6.54440191915 1081.09100325 0.0 -6.54779723906 983.073483395 0.0 -6.55110977376 788.112490237 0.0 -6.55452210771 761.293915286 0.0 -6.55808202081 704.675236456 0.0 -6.56200694686 550.411992302 0.0 -6.56644860228 582.342070182 0.0 -6.56993671231 426.680887482 0.0 -6.57372634094 394.173990999 0.0 -6.58021748768 264.658386502 0.0 -6.5856382067 209.291433224 0.0 -6.5941981466 161.769113342 0.0 -6.59667576315 79.4838263672 0.0 -6.59907585128 107.256525585 0.0 -6.60152328061 252.940362518 0.0 -6.60543602674 337.681567379 0.0 -6.60732031949 307.815275399 0.0 -6.61288710082 315.502649819 0.0 -6.62091386181 217.590824272 0.0 -6.63091386181 30.1161058287 0.0 -6.63681265682 8.78060058841 0.0 -6.63810512772 -158.609694564 0.0 -6.64127794724 -84.6501334189 0.0 -6.6450730973 -168.455032434 0.0 -6.65061283884 -86.6754858986 0.0 -6.65747448918 -83.387062945 0.0 -6.66051275988 -57.4941394026 0.0 -6.66854294628 1.4786758069 0.0 -6.67618191868 5.40732250691 0.0 -6.68082071678 42.9249222426 0.0 -6.68205361032 275.607096323 0.0 -6.68340861312 209.793575351 0.0 -6.684970319 294.849563784 0.0 -6.68714620214 152.759683106 0.0 -6.6904710688 255.016728367 0.0 -6.69575347322 224.133926684 0.0 -6.69946380772 272.278965572 0.0 -6.70360628606 279.571548565 0.0 -6.70968841352 256.710502328 0.0 -6.71529983346 259.47339722 0.0 -6.72137100627 192.615215804 0.0 -6.72687490627 279.707237994 0.0 -6.73658245938 288.849193236 0.0 -6.74420086071 357.12234423 0.0 -6.75420086071 399.055035941 0.0 -6.76420086071 432.416951783 0.0 -6.77044900116 460.019385165 0.0 -6.77817996496 446.169659979 0.0 -6.78642965206 423.87860534 0.0 -6.79371779607 396.269719416 0.0 -6.79695492009 360.458806494 0.0 -6.80406772614 331.087211678 0.0 -6.81406772614 313.920124461 0.0 -6.82190523917 303.413351331 0.0 -6.83096716032 286.209408101 0.0 -6.84093396139 276.615087861 0.0 -6.85093396139 271.353518083 0.0 -6.85834375345 265.332039716 0.0 -6.86525755212 249.879521353 0.0 -6.87291565225 245.270148717 0.0 -6.88068266324 246.34216347 0.0 -6.89044704523 243.969663475 0.0 -6.89986796613 245.233561299 0.0 -6.90951944371 246.860924445 0.0 -6.91822761214 246.289204862 0.0 -6.92702176838 243.91036959 0.0 -6.92848908551 252.648568076 0.0 -6.93779571119 249.302200876 0.0 -6.94243341916 253.6735337 0.0 -6.94725510641 255.265855118 0.0 -6.95004395361 258.944871225 0.0 -6.951826642 262.49987379 0.0 -6.95352281902 263.602908834 0.0 -6.95513422209 264.830175539 0.0 -6.95701084765 263.836857567 0.0 -6.95944455938 262.131370001 0.0 -6.96383056907 254.371362781 0.0 -6.96631021521 246.609091815 0.0 -6.97012311593 239.972756682 0.0 -6.97428098323 233.9410797 0.0 -6.97842143673 229.358227495 0.0 -6.98259979869 219.087795683 0.0 -6.98545591269 206.023910836 0.0 -6.98906685326 201.242373058 0.0 -6.99206344473 194.118277455 0.0 -6.99544783994 191.304689014 0.0 -6.99909766593 186.817002174 0.0 -7.00132783366 184.386910147 0.0 -7.00409772783 182.335888112 0.0 -7.00912570387 172.588192827 0.0 -7.01086715351 159.710208436 0.0 -7.01291164392 151.786285645 0.0 -7.01544153747 146.787351598 0.0 -7.01795313982 142.408725208 0.0 -7.02106899609 138.868799456 0.0 -7.0234194215 135.747222574 0.0 -7.02665162173 131.631354235 0.0 -7.02981367237 128.051757855 0.0 -7.03582487308 119.963878896 0.0 -7.0410887837 109.529662051 0.0 -7.04570874462 87.1423176522 0.0 -7.0477884601 72.5137367528 0.0 -7.05277275218 73.3701083597 0.0 -7.05738475228 71.9886340151 0.0 -7.06102740499 73.8229546932 0.0 -7.06416214247 80.4447866244 0.0 -7.06826792166 74.02282005 0.0 -7.06885518544 85.575332761 0.0 -7.06935518544 53.0301418875 0.0 -7.06987483755 67.5143433166 0.0 -7.07204473008 74.2136266899 0.0 -7.07543443939 72.6727514733 0.0 -7.07757754516 67.4338802331 0.0 -7.08036915771 56.5165083634 0.0 -7.08088675934 36.4420480337 0.0 -7.08461755407 27.3386183861 0.0 -7.08698072608 22.6090550352 0.0 -7.09092482273 17.0327250813 0.0 -7.09536583383 10.5183463976 0.0 -7.10007194887 6.50236756932 0.0 -7.10407625555 5.52639799632 0.0 -7.10876799872 2.92157294397 0.0 -7.11277619845 0.225693772643 0.0 -7.11683452453 -0.797698901217 0.0 -7.12110346257 5.54076143217 0.0 -7.12566705453 13.8707699806 0.0 -7.12795839011 29.1430442057 0.0 -7.13251424611 11.8622334442 0.0 -7.1379805479 -0.658583199765 0.0 -7.1437166032 -16.4712844776 0.0 -7.14918163785 -30.3617219968 0.0 -7.15248462099 -39.2900846344 0.0 -7.15644455841 -47.055897752 0.0 -7.16252828781 -57.1083249703 0.0 -7.16843912766 -66.263103551 0.0 -7.17485996299 0.0 0.0 -7.18329411137 0.0 0.0 -7.19261414077 0.0 0.0 -7.19836523051 0.0 0.0 -7.2046475564 0.0 0.0 -7.21352884009 0.0 0.0 -7.22352884009 0.0 0.0 -7.23156827038 0.0 0.0 -7.24156827038 0.0 0.0 -7.25156827038 0.0 0.0 -7.26156827038 0.0 0.0 -7.27156827038 0.0 0.0 -7.27989127093 0.0 0.0 -7.28887165781 0.0 0.0 -7.29887165781 0.0 0.0 -7.30659417838 0.0 0.0 -7.31536423181 0.0 0.0 -7.32536423181 0.0 0.0 -7.33355675908 0.0 0.0 -7.34355675908 0.0 0.0 -7.35355675908 0.0 0.0 -7.36355675908 0.0 0.0 -7.3730779337 0.0 0.0 -7.38255481533 0.0 0.0 -7.38908400679 0.0 0.0 -7.39901514835 0.0 0.0 -7.40363654068 0.0 0.0 -7.40718494413 0.0 0.0 -7.41718494413 0.0 0.0 -7.42718494413 0.0 0.0 -7.43091284917 0.0 0.0 -7.43568539594 0.0 0.0 -7.44055975912 0.0 0.0 -7.44172552516 0.0 0.0 -7.44982105453 0.0 0.0 -7.45982105453 0.0 0.0 -7.46163803825 0.0 0.0 -7.46504936461 0.0 0.0 -7.46812516521 0.0 0.0 -7.46963275886 0.0 0.0 -7.47171764017 0.0 0.0 -7.4723303293 0.0 0.0 -7.47367113491 0.0 0.0 -7.47616357052 0.0 0.0 -7.48123976124 0.0 0.0 -7.49123976124 0.0 0.0 -7.49725691341 0.0 0.0 -7.50343569743 0.0 0.0 -7.50606222142 0.0 0.0 -7.50673001049 0.0 0.0 -7.50847435676 0.0 0.0 -7.51036122088 0.0 0.0 -7.51601638329 0.0 0.0 -7.52215015197 0.0 0.0 -7.52440329581 0.0 0.0 -7.52616824641 0.0 0.0 -7.5299148044 0.0 0.0 -7.53226860702 0.0 0.0 -7.53580709778 0.0 0.0 -7.53978454789 0.0 0.0 -7.54559589243 0.0 0.0 -7.55216750627 0.0 0.0 -7.55647829593 0.0 0.0 -7.56041363921 0.0 0.0 -7.56398845225 0.0 0.0 -7.56828828856 0.0 0.0 -7.57043224717 0.0 0.0 -7.577288589 0.0 0.0 -7.5811145623 0.0 0.0 -7.5898524941 0.0 0.0 -7.59905075813 0.0 0.0 -7.60455601554 0.0 0.0 -7.61218036541 0.0 0.0 -7.61923818308 0.0 0.0 -7.62092501382 0.0 0.0 -7.6307697019 0.0 0.0 -7.6407697019 0.0 0.0 -7.64668346673 0.0 0.0 -7.65668346673 0.0 0.0 -7.66004188061 0.0 0.0 -7.66680325442 0.0 0.0 -7.67628117736 0.0 0.0 -7.68322685421 0.0 0.0 -7.68669435506 0.0 0.0 -7.6947159811 0.0 0.0 -7.7047159811 0.0 0.0 -7.71223568614 0.0 0.0 -7.71418974979 0.0 0.0 -7.72352696816 0.0 0.0 -7.72599050806 0.0 0.0 -7.73599050806 0.0 0.0 -7.74599050806 0.0 0.0 -7.75398824038 0.0 0.0 -7.76398824038 0.0 0.0 -7.77398824038 0.0 0.0 -7.78398824038 0.0 0.0 -7.79398824038 0.0 0.0 -7.80383193125 0.0 0.0 -7.81343850931 0.0 0.0 -7.82285010494 0.0 0.0 -7.8311005113 0.0 0.0 -7.8389709971 0.0 0.0 -7.84178315189 0.0 0.0 -7.84942342967 0.0 0.0 -7.85942342967 0.0 0.0 -7.86929322277 0.0 0.0 -7.87856935622 0.0 0.0 -7.88664646359 0.0 0.0 -7.89620026634 0.0 0.0 -7.90620026634 0.0 0.0 -7.9159533081 0.0 0.0 -7.9259533081 0.0 0.0 -7.9359533081 0.0 0.0 -7.94436338076 0.0 0.0 -7.95104089379 0.0 0.0 -7.95809070693 0.0 0.0 -7.96269558457 0.0 0.0 -7.96684785741 0.0 0.0 -7.97292311048 0.0 0.0 -7.9775797141 0.0 0.0 -7.98119064641 0.0 0.0 -7.98553493652 0.0 0.0 -7.98944322383 0.0 0.0 -7.994021478 0.0 0.0 -7.99617782084 0.0 0.0 -7.99802404614 0.0 0.0 -8.00261635594 0.0 0.0 -8.00726625037 0.0 0.0 -8.0096121135 0.0 0.0 -8.01114121094 2490.12168614 0.0 -8.01368099181 2147.56129257 0.0 -8.01501634634 582.411415053 0.0 -8.01595562792 1241.13375981 0.0 -8.01915296689 2367.70775205 0.0 -8.02317114444 2645.34428867 0.0 -8.02616070055 3106.87662991 0.0 -8.02674071147 5946.98367871 0.0 -8.02940266298 5495.38070567 0.0 -8.03107694976 5208.3790303 0.0 -8.03502826711 4193.2730742 0.0 -8.03759947509 3039.40781662 0.0 -8.04210804319 2119.15516351 0.0 -8.04642704025 1215.6727391 0.0 -8.04968210785 205.704437799 0.0 -8.05448405899 -273.092264228 0.0 -8.0583140345 -544.789163724 0.0 -8.06243981949 -541.285564126 0.0 -8.06642291116 -406.257512862 0.0 -8.07029403572 -197.139780062 0.0 -8.07390024967 45.4377065497 0.0 -8.07739790139 262.89119516 0.0 -8.08054741924 484.576171198 0.0 -8.08361393152 662.215989579 0.0 -8.08737779765 744.680815262 0.0 -8.09058364121 796.366557085 0.0 -8.09385916696 821.271904739 1.96258142827 -8.09711284607 833.060189896 3.35848834064 -8.10054273484 810.182949761 4.68357797724 -8.10388967939 772.797541231 4.99991951103 -8.10728783849 728.185328638 0.0 -8.11087803421 696.111336849 0.0 -8.11437259313 692.385051169 0.0 -8.11793272978 694.609933885 0.0 -8.12169705976 702.142170002 4.15732187388 -8.12536592679 714.705220082 4.07705880911 -8.1291125235 719.343229139 0.0 -8.13306269336 719.111772318 0.0 -8.13693796356 711.105609156 0.0 -8.14091051841 691.918653132 0.0 -8.14506317105 667.803837828 0.0 -8.14919045461 641.830716234 0.0 -8.15344538642 612.671322066 0.0 -8.15782795208 583.585177637 0.0 -8.16227324285 557.517642626 0.0 -8.16690650576 540.08455405 0.0 -8.1715811718 525.76482511 22.5047326384 -8.17634326853 513.575698173 21.8491564084 -8.18157033077 513.153459913 16.0715849685 -8.18664066052 519.851650335 10.5263749143 -8.19183577666 535.996912656 12.140198014 -8.19598826682 553.482546701 8.17223591204 -8.20303646666 573.211264755 10.6384726461 -8.2114698667 599.619996807 10.3264639267 -8.21938918195 634.054331425 8.73167372472 -8.22436830376 672.53442705 7.18985862648 -8.23436830376 696.608541124 11.7716991629 -8.24436830376 719.865697094 8.5333281132 -8.25416688941 743.26338686 4.4578466796 -8.26023485387 769.033212153 1.23984076307 -8.26485012787 791.507515656 0.0 -8.27279378495 806.919617131 0.0 -8.27832228296 826.391000996 0.0 -8.28563835124 841.599594402 0.0 -8.29203727934 857.502779172 0.0 -8.29827906662 870.995762414 0.0 -8.30418126012 886.619990047 0.0 -8.30935353625 900.774309151 0.0 -8.31519789689 916.403960184 0.0 -8.32050358334 931.781337896 0.0 -8.32571058385 941.932180801 0.0 -8.33033938815 956.760176452 0.0 -8.33500590015 967.494764621 0.0 -8.33930996482 977.207496158 0.0 -8.34295489174 987.028194513 0.0 -8.34708624958 990.170352769 0.0 -8.35114226755 990.057378727 0.0 -8.35535538749 989.51057315 0.0 -8.35928789175 993.030821138 0.0 -8.36246843211 986.053536407 0.0 -8.36591112397 983.376390888 0.0 -8.3698542745 972.978905759 0.0 -8.37316785857 970.059065812 0.0 -8.37722230518 953.396437368 0.0 -8.38101524569 935.145697305 0.0 -8.38373830691 913.800137937 0.653996304968 -8.38795678221 901.032195878 0.410406951643 -8.39048533687 880.778347109 0.0 -8.39315947009 859.141627151 0.0 -8.39585719544 840.867012756 0.0 -8.39881598208 821.363400288 0.0 -8.40187775382 814.544733152 0.0 -8.40713688715 790.429399865 0.0 -8.41017705987 739.539524682 0.0 -8.41246746323 729.216844331 0.0 -8.41565714341 718.186449126 0.0 -8.41994452211 723.651068108 0.0 -8.42534785444 673.538134758 0.0 -8.43317727 684.149158474 0.0 -8.43735407256 707.577301463 0.0 -8.4412599955 651.955705174 0.0 -8.44636466978 584.509420536 -1.06964533587 -8.44970333239 550.831120557 -1.10580707605 -8.45304840564 515.875174807 0.0 -8.45483329534 490.150131054 0.0 -8.45809323271 460.284275197 0.0 -8.45941881838 398.222767226 0.0 -8.46137172178 382.316714169 0.0 -8.46390671409 369.961785223 0.0 -8.46717590342 345.360464728 0.0 -8.47237053335 312.916857378 0.0 -8.47691343632 304.608477841 0.0 -8.4790064583 309.497892403 0.0 -8.48057855481 289.022741346 0.0 -8.48304973152 272.599291259 0.0 -8.4910352 409.492823589 0.0 -8.49754726299 414.201294723 0.0 -8.50066570853 430.725613099 0.0 -8.50458590187 343.640605909 0.0 -8.51319334796 331.308409991 0.0 -8.52078457828 406.663674063 0.0 -8.52369824058 501.165978237 0.0 -8.5278207061 472.961395122 0.0 -8.53253397735 426.03831739 0.0 -8.53856994057 437.489403069 0.0 -8.5430589083 445.093473652 0.0 -8.55036636592 449.792579213 0.0 -8.55929779548 440.553737047 0.0 -8.56443204729 419.345252111 0.0 -8.57443204729 381.786401637 0.0 -8.58443204729 350.176737796 0.0 -8.59402185558 329.850021145 0.0 -8.59651381973 290.170728937 0.0 -8.60298827389 282.793227503 0.0 -8.61152689506 288.173013502 0.0 -8.61581337744 310.053389035 0.0 -8.62113062799 296.2447762 0.0 -8.62839426274 310.169979415 0.0 -8.63366148944 329.354476298 0.0 -8.63450786925 426.675975743 0.0 -8.63500786925 534.782220017 0.0 -8.63550786925 606.157631032 0.0 -8.63609362098 642.152241408 0.0 -8.63712315873 654.630121339 0.0 -8.63997533498 645.096692643 0.0 -8.64484826362 623.318437388 0.0 -8.64654266388 583.896748611 0.0 -8.65117893207 552.128128094 0.0 -8.66027611264 520.858865741 0.0 -8.66682917661 444.311825362 0.0 -8.67176257923 359.427728034 0.0 -8.67622020411 280.05969191 0.0 -8.68162272282 232.471833255 0.0 -8.6866232877 189.464598319 0.0 -8.68842060922 111.196700989 0.0 -8.69051010818 72.0919740698 0.0 -8.69355489344 62.1413494926 0.0 -8.69991108754 76.1045731988 0.0 -8.7039349495 109.627318208 0.0 -8.71080859199 140.995648462 0.0 -8.715274853 186.594482191 0.0 -8.71766486415 272.208146081 0.0 -8.72048147398 327.273475984 0.0 -8.72690640211 357.238975864 0.0 -8.73234790768 394.54625182 0.0 -8.73812214021 433.489883734 0.0 -8.74641660811 447.757058438 0.0 -8.75469376906 463.425065238 0.0 -8.75644224611 420.787731836 0.0 -8.75791645776 455.250846401 0.0 -8.7591689442 478.312831482 0.0 -8.76068925763 496.085933401 0.0 -8.76269749961 507.021103382 0.0 -8.76573491262 508.693090007 0.0 -8.7704446094 485.597483541 0.0 -8.77413531158 463.638630144 0.0 -8.777604102 437.574715889 0.0 -8.78048153297 401.532279166 0.0 -8.78453058647 374.638216035 0.0 -8.78785405659 341.858636816 0.0 -8.7896800195 296.600210074 0.0 -8.79267273394 268.684748405 0.0 -8.8000701882 253.604832945 0.0 -8.80457295996 238.994488654 0.0 -8.81038450381 230.651875848 0.0 -8.81711610992 225.227109892 0.0 -8.82191875202 227.007066158 0.0 -8.82481705144 233.446946018 0.0 -8.82938859941 239.474167794 0.0 -8.83329059298 248.367462923 0.0 -8.83929004147 253.612167887 0.0 -8.84685095559 257.708996416 0.0 -8.85425477981 262.433298848 0.0 -8.86010820461 269.375709074 0.0 -8.86519624342 273.967921095 0.0 -8.86936334932 279.624947134 0.0 -8.87394920522 279.061267761 0.0 -8.87592955565 284.033087089 0.0 -8.87825322256 286.235399411 0.0 -8.881564836 282.00023619 0.0 -8.88507792537 273.345846069 0.0 -8.88951088748 260.259403144 0.0 -8.895119298 243.951478269 0.0 -8.90150116993 221.56020743 0.0 -8.90545280425 202.236400268 0.0 -8.91031331463 185.568981457 0.0 -8.91659945081 169.952194413 0.0 -8.92106228212 156.732007421 0.0 -8.924465145 140.604531627 0.0 -8.92853443268 129.752844863 0.0 -8.93145535649 114.718964594 0.0 -8.93466527875 107.121188946 0.0 -8.93864647155 99.7244287365 0.0 -8.94303352012 91.5907349794 0.0 -8.94666155801 84.26359938 0.0 -8.94719994159 76.0580856634 0.0 -8.94769994159 79.462957295 0.0 -8.95270421624 75.0227657558 0.0 -8.95320421624 67.6007732824 0.0 -8.95386880604 69.4838450868 0.0 -8.95553942726 71.8612582053 0.0 -8.95683208319 69.706128775 0.0 -8.95816019939 72.168248797 0.0 -8.96054046541 67.1503023244 0.0 -8.96397201467 63.2341104439 0.0 -8.9683917149 54.6703364608 0.0 -8.97070332851 48.4524003853 0.0 -8.97351757069 43.5670804994 0.0 -8.97572985116 41.9775076422 0.0 -8.97887872907 37.3560835996 0.0 -8.98169674673 33.1569695459 0.0 -8.98481248862 29.2867178576 0.0 -8.98802006815 26.4070130871 0.0 -8.99297909253 22.2252798746 0.0 -8.99658049589 20.0633956295 0.0 -9.00034644673 13.145378092 0.0 -9.00406350751 8.6852426123 0.0 -9.01030362264 1.56342355849 0.0 -9.01529659699 -4.24092915579 0.0 -9.02250414932 -9.96065979107 0.0 -9.03024693451 -13.592475662 0.0 -9.03894335619 -11.8604492762 0.0 -9.04735559195 -24.4272402388 0.0 -9.0572075014 -33.7570486562 0.0 -9.06504300883 -36.175817231 0.0 -9.07373302934 0.0 0.0 -9.080579508 0.0 0.0 -9.08754256654 0.0 0.0 -9.09380747279 0.0 0.0 -9.10380747279 0.0 0.0 -9.11380747279 0.0 0.0 -9.1222864169 0.0 0.0 -9.1322864169 0.0 0.0 -9.1422864169 0.0 0.0 -9.1522864169 0.0 0.0 -9.1622864169 0.0 0.0 -9.1722864169 0.0 0.0 -9.176963539 0.0 0.0 -9.18468367184 0.0 0.0 -9.18896527701 0.0 0.0 -9.19590933982 0.0 0.0 -9.20590933982 0.0 0.0 -9.20944840619 0.0 0.0 -9.21944840619 0.0 0.0 -9.22905044367 0.0 0.0 -9.23905044367 0.0 0.0 -9.24649737291 0.0 0.0 -9.25598499039 0.0 0.0 -9.26298050456 0.0 0.0 -9.26768768204 0.0 0.0 -9.27337165225 0.0 0.0 -9.27633599593 0.0 0.0 -9.28254250048 0.0 0.0 -9.28868840358 0.0 0.0 -9.29475718786 0.0 0.0 -9.30056683733 0.0 0.0 -9.30651268411 0.0 0.0 -9.31182082175 0.0 0.0 -9.31694924936 0.0 0.0 -9.32186070606 0.0 0.0 -9.32682778086 0.0 0.0 -9.33276052922 0.0 0.0 -9.34001763911 0.0 0.0 -9.34845319571 0.0 0.0 -9.35044909164 0.0 0.0 -9.36044909164 0.0 0.0 -9.3619378398 0.0 0.0 -9.36727530464 0.0 0.0 -9.37727530464 0.0 0.0 -9.38727530464 0.0 0.0 -9.39727530464 0.0 0.0 -9.40727530464 0.0 0.0 -9.41727530464 0.0 0.0 -9.42727530464 0.0 0.0 -9.43693640831 0.0 0.0 -9.44460317619 0.0 0.0 -9.44716411717 0.0 0.0 -9.45578694763 0.0 0.0 -9.4563989745 0.0 0.0 -9.45731422583 0.0 0.0 -9.45994734303 0.0 0.0 -9.4625612176 0.0 0.0 -9.46514361346 0.0 0.0 -9.46880922452 0.0 0.0 -9.47289946604 0.0 0.0 -9.47746196578 0.0 0.0 -9.48256105162 0.0 0.0 -9.4862318903 0.0 0.0 -9.48805021419 0.0 0.0 -9.49053409667 0.0 0.0 -9.49466260161 0.0 0.0 -9.49586151161 0.0 0.0 -9.49714923241 0.0 0.0 -9.50369014034 0.0 0.0 -9.50502850529 0.0 0.0 -9.51146472623 0.0 0.0 -9.51769865878 0.0 0.0 -9.52376470002 0.0 0.0 -9.53154326613 0.0 0.0 -9.53585256487 0.0 0.0 -9.5414599631 0.0 0.0 -9.54912648796 0.0 0.0 -9.55575195685 0.0 0.0 -9.56218484295 0.0 0.0 -9.56465821984 0.0 0.0 -9.57465821984 0.0 0.0 -9.58344430469 0.0 0.0 -9.58963748608 0.0 0.0 -9.59336692495 0.0 0.0 -9.60336692495 0.0 0.0 -9.60946242597 0.0 0.0 -9.61364230621 0.0 0.0 -9.61442640511 0.0 0.0 -9.62208215125 0.0 0.0 -9.63049354466 0.0 0.0 -9.63481748828 0.0 0.0 -9.64172509441 0.0 0.0 -9.64656695069 0.0 0.0 -9.64958616242 0.0 0.0 -9.65184259218 0.0 0.0 -9.65557478841 0.0 0.0 -9.65918445369 0.0 0.0 -9.65995307274 0.0 0.0 -9.66162335554 0.0 0.0 -9.66346569496 0.0 0.0 -9.66648718431 0.0 0.0 -9.67254849481 0.0 0.0 -9.67750055916 0.0 0.0 -9.68422524822 0.0 0.0 -9.69241444436 0.0 0.0 -9.69922784436 0.0 0.0 -9.70756501335 0.0 0.0 -9.7174186189 0.0 0.0 -9.7274186189 0.0 0.0 -9.73331494148 0.0 0.0 -9.74228742534 0.0 0.0 -9.74913951351 0.0 0.0 -9.75654392848 0.0 0.0 -9.76111995143 0.0 0.0 -9.76800401926 0.0 0.0 -9.77521026922 0.0 0.0 -9.77913879125 0.0 0.0 -9.78290086984 0.0 0.0 -9.78621298905 0.0 0.0 -9.78898212725 0.0 0.0 -9.79275176562 0.0 0.0 -9.79335410368 0.0 0.0 -9.79475451031 0.0 0.0 -9.79811581256 0.0 0.0 -9.80178016527 0.0 0.0 -9.80293571714 0.0 0.0 -9.80483682632 0.0 0.0 -9.80783748133 0.0 0.0 -9.80833748133 0.0 0.0 -9.80883748133 0.0 0.0 -9.81333887187 0.0 0.0 -9.81866217614 0.0 0.0 -9.82789434465 0.0 0.0 -9.83456102833 0.0 0.0 -9.8382463432 0.0 0.0 -9.84263978936 0.0 0.0 -9.84762905165 0.0 0.0 -9.85251388922 0.0 0.0 -9.85710471045 0.0 0.0 -9.86307244434 0.0 0.0 -9.86725526346 0.0 0.0 -9.87144077108 0.0 0.0 -9.87448531552 0.0 0.0 -9.87841822553 0.0 0.0 -9.88582009437 0.0 0.0 -9.89302136098 0.0 0.0 -9.90115074706 0.0 0.0 -9.90576370281 0.0 0.0 -9.90862493257 1513.25191122 0.0 -9.91328685338 1334.62608544 0.0 -9.91672917621 1723.10259728 0.0 -9.92006806158 2219.23337452 0.0 -9.92341613384 2054.04267889 0.0 -9.92737563477 2384.71529806 0.0 -9.9305805801 2399.37259461 0.0 -9.93581908616 2200.43566784 0.0 -9.94172371013 1831.11944514 0.0 -9.94626121327 1442.60997622 0.0 -9.95271215354 1062.2551205 0.0 -9.95847586125 708.322431574 0.0 -9.96379918173 438.763081647 0.0 -9.96967560479 255.3736949 0.0 -9.97595090416 188.568150902 0.0 -9.9808717522 169.448796851 0.0 -9.98259914752 117.849080173 0.0 -9.98424430129 150.801702524 0.0 -9.98564782219 182.076363861 0.0 -9.98942773876 230.897308067 0.0 -9.99470608136 303.078820115 0.0 -9.99970684098 393.866175956 0.0 -10.0010002861 636.859304948 0.0 -10.0044594484 729.603673795 0.0 -10.0074600909 802.486168276 0.0 -10.0123572876 827.840917327 0.0 -10.0185149558 824.85408217 0.0 -10.0257305137 803.752776452 -7.69456653944 -10.0328433981 767.616416354 -41.0375793982 -10.039032774 726.38361099 0.0 -10.0477515711 698.484228437 2.80392603289 -10.0548073226 656.556123912 2.41657129676 -10.0648073226 630.835108219 4.8127115681 -10.0748073226 601.375039927 4.6142782405 -10.0845329015 575.93278238 4.55310080322 -10.0934504862 555.253666279 0.0 -10.1000344705 522.840606249 0.0 -10.1100344705 516.49658877 0.0 -10.1200344705 515.648973587 0.0 -10.1298127318 523.428255523 0.0 -10.1398127318 537.120298217 0.0 -10.1498127318 554.636601834 3.29179377714 -10.1598127318 576.679776708 2.15922754244 -10.1698127318 599.476229215 2.24496821664 -10.1798127318 627.338388397 0.0 -10.1841749104 669.709614613 0.0 -10.1941749104 694.807236167 0.0 -10.2034208063 723.832237538 0.0 -10.2115446678 750.509760192 0.0 -10.2190590205 779.44696431 0.0 -10.2241752688 817.86103448 0.0 -10.2305038354 842.734249891 0.0 -10.2369262283 871.725325693 0.0 -10.2427067404 893.559743436 0.0 -10.2471464222 910.824276519 0.0 -10.2510805127 937.742863618 0.0 -10.2515805127 1021.83790323 0.0 -10.2520805127 1067.24235811 0.0 -10.2525805127 1122.37038009 0.0 -10.2576369559 1139.92234567 0.0 -10.2619848644 1118.17880887 0.0 -10.2666164767 1167.49336163 0.0 -10.2712479371 1157.69022548 0.0 -10.2761946461 1132.48719572 0.0 -10.281103282 1079.10150539 0.0 -10.2863758322 1032.29808825 0.0 -10.2895561335 936.059739485 0.0 -10.2937352571 880.653044131 0.0 -10.2961726384 827.080694556 0.0 -10.2981167109 763.772229877 0.0 -10.3049825027 727.693855055 0.0 -10.3134978021 704.274540865 0.0 -10.3206724914 696.135163924 0.0 -10.3257669072 683.804634217 0.0 -10.332220143 686.60099927 0.0 -10.3368519933 693.947230123 0.0 -10.3460064887 690.161801615 0.0 -10.3484792422 662.358576289 0.0 -10.3525461908 693.132458788 0.0 -10.3583270535 702.113758197 -0.84743599579 -10.3650119304 684.992143027 -0.896682744544 -10.3713814866 662.557600773 -1.11240687795 -10.3813814866 624.401011607 -1.28412098101 -10.3881483763 572.811889551 -1.40541341227 -10.3981483763 517.435997449 -1.34182351841 -10.40688536 457.443372721 -1.50452764649 -10.4149249157 405.365638902 0.0 -10.4209288906 357.220540445 0.0 -10.4259256011 319.617328025 0.0 -10.4300638086 288.556456901 0.0 -10.4338626281 278.936561406 0.0 -10.4364138727 271.593185118 0.0 -10.4386470738 269.332220101 0.0 -10.4410598962 273.117349497 0.0 -10.4434424271 286.989194186 0.0 -10.4458644988 374.859944779 0.0 -10.448259294 374.599225364 0.0 -10.4509536646 407.388611829 0.0 -10.4525831918 403.51241324 0.0 -10.4553120978 374.22547076 0.0 -10.4599192918 388.859115116 0.0 -10.4644331012 569.876427479 0.0 -10.4678337434 671.022846743 0.0 -10.4712386829 654.518625759 0.0 -10.4752300181 587.250469974 0.0 -10.4757300181 496.181216489 0.0 -10.4795588508 631.591111614 0.0 -10.4851906351 650.662399859 0.0 -10.4902706987 601.082896304 0.0 -10.4959688229 537.206539842 0.0 -10.5004470023 452.140955006 0.0 -10.5042924999 388.480323728 0.0 -10.5066053073 289.681667691 0.0 -10.5086352561 207.812738794 0.0 -10.5148426236 208.769460366 0.0 -10.5202766884 199.152275669 0.0 -10.5291566586 202.068715158 0.0 -10.5391566586 235.611398553 0.0 -10.5491566586 300.216962936 0.0 -10.554771356 396.78377823 0.0 -10.5630179352 458.408873684 0.0 -10.5730179352 504.996909318 0.0 -10.5830179352 547.919407019 0.0 -10.5913322364 579.413449448 0.0 -10.5926559779 725.58672795 0.0 -10.5933207104 898.639021881 0.0 -10.6024127312 882.137504769 0.0 -10.6124127312 830.788355337 0.0 -10.6224127312 744.695403011 0.0 -10.6324127312 616.444142341 0.0 -10.6365254907 355.548471242 0.0 -10.6465254907 246.029404266 0.0 -10.6554412248 160.096007978 0.0 -10.6636200111 103.360891678 0.0 -10.667343748 29.2085694772 0.0 -10.6766924442 30.233170063 0.0 -10.6866924442 61.6779638561 0.0 -10.6963248546 122.431097353 0.0 -10.6985074512 292.306829888 0.0 -10.706349701 335.237556433 0.0 -10.7151433216 364.516279648 0.0 -10.724566618 381.39888831 0.0 -10.7332996366 385.536703328 0.0 -10.7402806768 407.587064484 0.0 -10.7461501763 396.602394928 0.0 -10.7529672452 377.296054023 0.0 -10.7573420771 356.057864796 0.0 -10.7586282994 341.819548281 0.0 -10.7648120647 299.757681491 0.0 -10.7683704885 273.988170773 0.0 -10.7719430367 257.834940392 0.0 -10.7783897161 247.39295944 0.0 -10.7829811671 229.232158255 0.0 -10.7868145149 214.23671143 0.0 -10.7876939648 188.003367124 0.0 -10.7881939648 166.622133119 0.0 -10.7938677276 158.470513955 0.0 -10.7971702622 153.329833094 0.0 -10.8023251211 147.586730538 0.0 -10.8077166929 141.59868377 0.0 -10.814537875 135.302731679 0.0 -10.8177680308 134.023565182 0.0 -10.8187006643 128.195578927 0.0 -10.8249724545 119.037407077 0.0 -10.8292435559 117.45354397 0.0 -10.8297435559 177.114054451 0.0 -10.8357204041 160.91003798 0.0 -10.8392201281 142.239563369 0.0 -10.8430981494 124.826823759 0.0 -10.8444366143 104.737576756 0.0 -10.8486740661 95.0206370439 0.0 -10.8534826398 84.2691577393 0.0 -10.8575663365 79.5011281546 0.0 -10.8588421648 77.5721799798 0.0 -10.8615359122 73.7300668015 0.0 -10.8652855747 65.8643814425 0.0 -10.8675587053 60.0112089176 0.0 -10.8704706526 55.1431646133 0.0 -10.8715514651 53.3713119114 0.0 -10.8743205376 45.6959307386 0.0 -10.8782327998 42.493581464 0.0 -10.8828766452 39.5265208263 0.0 -10.8889367341 34.3109325367 0.0 -10.8938955545 33.9934095877 0.0 -10.8980209769 34.1629455603 0.0 -10.9019389189 40.134362965 0.0 -10.9049953518 18.371666012 0.0 -10.907708792 25.7052228552 0.0 -10.9104055271 22.3045079887 0.0 -10.9139009911 13.3610728109 0.0 -10.9186065551 6.03766000615 0.0 -10.9241426693 0.95389453101 0.0 -10.9285457914 1.96230526426 0.0 -10.9317955104 -2.10526639059 0.0 -10.935961122 -9.49994069577 0.0 -10.9394979568 -11.4070922333 0.0 -10.9462193107 -24.9011826126 0.0 -10.9479888279 -78.3394752473 0.0 -10.9550553161 -48.7116738863 0.0 -10.9618591136 -66.5345385639 0.0 -10.9693800916 -33.6616856601 0.0 -10.9745806304 0.0 0.0 -10.9817718746 0.0 0.0 -10.9870241161 0.0 0.0 -10.9955874466 0.0 0.0 -11.0029482058 0.0 0.0 -11.0129482058 0.0 0.0 -11.0185381646 0.0 0.0 -11.0207348064 0.0 0.0 -11.0307348064 0.0 0.0 -11.0407348064 0.0 0.0 -11.0507348064 0.0 0.0 -11.0580510401 0.0 0.0 -11.0604468052 0.0 0.0 -11.0630897105 0.0 0.0 -11.0669129825 0.0 0.0 -11.0734612408 0.0 0.0 -11.0834612408 0.0 0.0 -11.0848984128 0.0 0.0 -11.0877326782 0.0 0.0 -11.0905497681 0.0 0.0 -11.1005497681 0.0 0.0 -11.1105497681 0.0 0.0 -11.1180806305 0.0 0.0 -11.1280806305 0.0 0.0 -11.1380806305 0.0 0.0 -11.1480806305 0.0 0.0 -11.1572064054 0.0 0.0 -11.1663968774 0.0 0.0 -11.1750974017 0.0 0.0 -11.1831036021 0.0 0.0 -11.1910493304 0.0 0.0 -11.198240774 0.0 0.0 -11.2037819305 0.0 0.0 -11.210134945 0.0 0.0 -11.2160087555 0.0 0.0 -11.221743304 0.0 0.0 -11.2276047263 0.0 0.0 -11.2333752462 0.0 0.0 -11.2385381637 0.0 0.0 -11.2436631851 0.0 0.0 -11.2488676115 0.0 0.0 -11.2536480201 0.0 0.0 -11.258246922 0.0 0.0 -11.2626472013 0.0 0.0 -11.2661686963 0.0 0.0 -11.2706143468 0.0 0.0 -11.2746238091 0.0 0.0 -11.2791098287 0.0 0.0 -11.2845032752 0.0 0.0 -11.2902106467 0.0 0.0 -11.2960294266 0.0 0.0 -11.300049682 0.0 0.0 -11.3018655387 0.0 0.0 -11.3060159457 0.0 0.0 -11.3118063571 0.0 0.0 -11.3124619342 0.0 0.0 -11.3138410652 0.0 0.0 -11.3164772454 0.0 0.0 -11.3230747141 0.0 0.0 -11.3272781758 0.0 0.0 -11.3372781758 0.0 0.0 -11.3423266888 0.0 0.0 -11.3450794496 0.0 0.0 -11.3490734668 0.0 0.0 -11.3564003925 0.0 0.0 -11.360782485 0.0 0.0 -11.3643292748 0.0 0.0 -11.3672396273 0.0 0.0 -11.3712250572 0.0 0.0 -11.3760153896 0.0 0.0 -11.3821059455 0.0 0.0 -11.3882737502 0.0 0.0 -11.3925942793 0.0 0.0 -11.3967109821 0.0 0.0 -11.4002554889 0.0 0.0 -11.4032148065 0.0 0.0 -11.4081700598 0.0 0.0 -11.4101604445 0.0 0.0 -11.4160648145 0.0 0.0 -11.4207432291 0.0 0.0 -11.426578548 0.0 0.0 -11.4327497645 0.0 0.0 -11.4361515719 0.0 0.0 -11.4461515719 0.0 0.0 -11.455930295 0.0 0.0 -11.4629760463 0.0 0.0 -11.4694915699 0.0 0.0 -11.4726780744 0.0 0.0 -11.4770605465 0.0 0.0 -11.4811674283 0.0 0.0 -11.488077001 0.0 0.0 -11.4968725192 0.0 0.0 -11.5067304256 0.0 0.0 -11.5147819373 0.0 0.0 -11.5247819373 0.0 0.0 -11.5336308751 0.0 0.0 -11.5373647012 0.0 0.0 -11.5396812181 0.0 0.0 -11.5459421775 0.0 0.0 -11.5559421775 0.0 0.0 -11.5629507601 0.0 0.0 -11.5649132258 0.0 0.0 -11.5713998497 0.0 0.0 -11.572968569 0.0 0.0 -11.5794176892 0.0 0.0 -11.5880759031 0.0 0.0 -11.5940203057 0.0 0.0 -11.5983052802 0.0 0.0 -11.6068645258 0.0 0.0 -11.6093402224 0.0 0.0 -11.6145586978 0.0 0.0 -11.6192712712 0.0 0.0 -11.6223277842 0.0 0.0 -11.6268871794 0.0 0.0 -11.6306534812 0.0 0.0 -11.6358911868 0.0 0.0 -11.6423387576 0.0 0.0 -11.6511837542 0.0 0.0 -11.6600760215 0.0 0.0 -11.6693195706 0.0 0.0 -11.6789505279 0.0 0.0 -11.6838642876 0.0 0.0 -11.6882556243 0.0 0.0 -11.6896213621 0.0 0.0 -11.6949611547 0.0 0.0 -11.6987057633 0.0 0.0 -11.7039748531 0.0 0.0 -11.707727422 0.0 0.0 -11.7129958829 0.0 0.0 -11.716472047 0.0 0.0 -11.7216368703 0.0 0.0 -11.7292249828 0.0 0.0 -11.7321718608 0.0 0.0 -11.7421718608 0.0 0.0 -11.7505872504 0.0 0.0 -11.7605872504 0.0 0.0 -11.7623677969 0.0 0.0 -11.7686051409 0.0 0.0 -11.7786051409 0.0 0.0 -11.7809183904 0.0 0.0 -11.7909183904 0.0 0.0 -11.7936203199 0.0 0.0 -11.7955799738 0.0 0.0 -11.8055799738 0.0 0.0 -11.8136941204 1045.90534931 0.0 -11.8175491811 1950.04845168 0.0 -11.8198007307 2976.71578962 0.0 -11.8232858256 3368.61040043 0.0 -11.8278744733 3487.05358707 0.0 -11.832941006 3195.76300593 0.0 -11.8377893585 2683.14365356 0.0 -11.8422800211 1949.84915294 0.0 -11.8458352083 1169.93530453 0.0 -11.8490501402 424.776071733 0.0 -11.8548142932 57.2938112298 0.0 -11.8591153254 -122.261923163 0.0 -11.863461701 -157.915807738 0.0 -11.8719140149 -89.4079677112 0.0 -11.8741314723 55.3126701754 0.0 -11.877093778 152.089121408 0.0 -11.880487823 256.545671894 0.0 -11.8847622463 376.833181499 0.0 -11.8896220123 488.651320483 0.0 -11.8945939238 572.162701737 0.0 -11.9029118768 617.166423031 2.6091730456 -11.9047220075 872.927211208 3.45522315241 -11.9123246691 900.473795751 0.0 -11.9169408627 938.666045483 0.0 -11.9221441753 930.663114525 0.0 -11.9274022488 923.351696058 0.0 -11.9339674408 903.290931768 22.6112965768 -11.9409414035 858.185285193 17.164665824 -11.9494864728 804.765735253 5.61801627174 -11.9589252311 756.894494301 17.1503196243 -11.9618638241 634.091781254 -73.0796850859 -11.970466155 605.267872129 26.4923822019 -11.980466155 583.591608033 10.2491222538 -11.9881795401 564.179526971 7.48690091728 -11.9963328628 550.45334788 14.0542333533 -12.0063328628 555.626739794 22.4294105522 -12.0163328628 564.13569623 11.2025081679 -12.0263328628 581.629162391 11.1236309215 -12.0307934915 595.763082234 9.30883508358 -12.0407934915 612.444669867 6.49221536704 -12.0507934915 631.980392059 7.45854771462 -12.0607934915 656.106557547 7.5533724416 -12.0665679743 688.127858698 0.0 -12.06781073 785.102913083 13.3618367447 -12.0692996778 839.164918145 12.9422271701 -12.0714180321 867.186808476 22.9913715049 -12.0754755067 879.811917073 12.6583632784 -12.0841445422 890.440319196 14.2557855911 -12.0941129355 894.18006306 15.3066517697 -12.1036386498 894.016268799 26.6268743375 -12.1124863284 885.807015651 22.2537872779 -12.120870519 872.323961749 22.3662057871 -12.1285778344 857.815363029 20.5739968798 -12.1356725747 842.021176289 10.1570375417 -12.1415814781 836.623593875 10.8333729873 -12.1474457272 835.643487297 12.7524912518 -12.1531572929 847.729212092 9.24151609438 -12.158936723 868.35930483 8.20106751987 -12.1613453982 923.568378008 -0.174834482595 -12.1658852324 953.815968603 -7.54601591107 -12.1722116171 988.833722139 0.0 -12.1768911076 1023.2392135 0.0 -12.1826485036 1058.50831979 0.0 -12.1868291752 1089.42026888 0.0 -12.1910916852 1113.00524309 0.0 -12.197081503 1129.48598923 0.0 -12.2016449524 1175.87692015 0.0 -12.2077563433 1195.29945577 0.0 -12.2151545577 1175.90799682 0.0 -12.2218992964 1174.28021479 0.0 -12.2283999373 1162.48506792 0.0 -12.2316546505 1165.25336077 0.0 -12.2375439618 1137.6614213 0.0 -12.2428568996 1126.69202309 0.0 -12.2444223196 1018.25746004 0.0 -12.2497142045 997.331718093 0.0 -12.2558906083 954.800520429 0.0 -12.2611464131 861.333106781 0.0 -12.267351136 785.485441968 0.0 -12.2753364905 677.858447098 0.0 -12.279591353 537.991658148 -1.5189210898 -12.2886866974 438.621880208 0.0 -12.2961548145 351.654964654 0.0 -12.3012815143 263.842693424 0.0 -12.3049823726 249.127062619 0.0 -12.3096059781 226.312897632 0.0 -12.3161997127 200.437857241 0.0 -12.323157611 158.898582412 0.0 -12.327347364 142.614482597 0.0 -12.337347364 116.148165262 0.0 -12.347347364 104.47605566 0.0 -12.357347364 129.494843744 0.0 -12.3635089337 532.831968616 0.0 -12.3675049728 618.638510215 0.0 -12.3739389218 504.124251388 0.0 -12.37750508 361.954827793 0.0 -12.3822219049 347.208948077 0.0 -12.3903809181 286.286085583 0.0 -12.3993231735 360.317980903 0.0 -12.4093231735 296.350029012 0.0 -12.419034745 383.023246674 0.0 -12.4214023872 555.296680197 0.0 -12.4314023872 542.179937704 0.0 -12.4414023872 530.676917838 0.0 -12.4471559592 543.643891553 0.0 -12.4495617491 565.813386441 0.0 -12.452503625 579.909425974 0.0 -12.4597497017 564.273129252 0.0 -12.4642181494 563.300074849 0.0 -12.4674826474 539.150221641 0.0 -12.4691502265 525.05971269 0.0 -12.4791502265 495.069177248 0.0 -12.4860180292 466.619368658 0.0 -12.4934993486 474.455259058 0.0 -12.4991386114 428.196792263 0.0 -12.5033838589 445.894618341 0.0 -12.5086907947 415.07351142 0.0 -12.5120956973 420.590694677 0.0 -12.5148594327 406.90310396 0.0 -12.519534881 396.748712037 0.0 -12.5236431564 386.49372263 0.0 -12.529681646 387.625614232 0.0 -12.5355372233 386.951824915 0.0 -12.5376919371 370.19340024 0.0 -12.5427533935 386.217265565 0.0 -12.5476187744 397.912338343 0.0 -12.5512719152 397.555196814 0.0 -12.5560067695 398.14153458 0.0 -12.559221762 398.915807331 0.0 -12.5660772532 398.154787011 0.0 -12.5729233829 400.350656305 0.0 -12.5772634057 402.416100992 0.0 -12.5819914761 408.951394487 0.0 -12.5876177546 409.701490718 0.0 -12.5938254335 408.284802047 0.0 -12.5992867253 398.86611743 0.0 -12.6071501842 394.383782266 0.0 -12.6171501842 384.48948833 0.0 -12.6232989987 374.928875776 0.0 -12.6269376153 365.538972552 0.0 -12.6339015271 352.468139869 0.0 -12.6415003027 342.076268995 0.0 -12.6471586615 326.178058843 0.0 -12.6539462989 309.722088583 0.0 -12.6583572814 298.034162805 0.0 -12.6631953143 289.229786908 0.0 -12.6646605754 308.833033783 0.0 -12.6661988818 284.717414853 0.0 -12.6723759312 267.769943994 0.0 -12.6758217029 253.549014254 0.0 -12.6797561208 246.139573797 0.0 -12.6818655769 245.825789061 0.0 -12.6839523871 249.486208009 0.0 -12.6861691064 252.207257213 0.0 -12.6896594263 251.875252316 0.0 -12.6942080335 248.248179391 0.0 -12.697676486 247.845734823 0.0 -12.7031607885 245.792944961 0.0 -12.7064629474 246.758763574 0.0 -12.7087750273 252.745598512 0.0 -12.7145183997 251.833373649 0.0 -12.7164471894 259.690806261 0.0 -12.7210505556 258.752784718 0.0 -12.7217020589 296.045572262 0.0 -12.7285844583 279.470193386 0.0 -12.7340877893 262.097548976 0.0 -12.7369575885 243.618376227 0.0 -12.739572517 228.61415011 0.0 -12.7433812935 211.95269684 0.0 -12.7489723129 189.774527394 0.0 -12.7526613248 164.777469325 0.0 -12.7546164313 140.426977629 0.0 -12.7557722922 117.626532479 0.0 -12.7562722922 85.434292464 0.0 -12.7601474109 84.8314401859 0.0 -12.7645892453 85.00133274 0.0 -12.7665144879 91.159829842 0.0 -12.7703264893 89.4130509446 0.0 -12.773173065 82.560188972 0.0 -12.7753316325 70.5490324884 0.0 -12.7764212482 66.5304322398 0.0 -12.7769212482 65.4083759077 0.0 -12.7783590819 52.3655745036 0.0 -12.7805607122 63.2229891566 0.0 -12.7843621073 58.9163835333 0.0 -12.7877183109 48.7648801215 0.0 -12.7902359945 39.2192528257 0.0 -12.7942571575 30.3915923385 0.0 -12.7979334303 21.5778056477 0.0 -12.8026028926 8.65401586382 0.0 -12.8073388289 3.14964639971 0.0 -12.8101241815 8.36611978613 0.0 -12.8134401011 6.4678109814 0.0 -12.8176502528 0.687180505541 0.0 -12.8223658227 -3.2518979831 0.0 -12.8263784686 -8.32826442778 0.0 -12.8295611794 -20.7482040989 0.0 -12.8322670521 -25.4383186191 0.0 -12.8358645038 -68.5639327382 0.0 -12.8413729971 -53.8097255794 0.0 -12.8465371723 -55.4818122522 0.0 -12.8538888138 0.0 0.0 -12.8612625182 0.0 0.0 -12.8692200611 0.0 0.0 -12.8768630902 0.0 0.0 -12.8822353305 0.0 0.0 -12.8891589903 0.0 0.0 -12.8973225058 0.0 0.0 -12.9073225058 0.0 0.0 -12.917008179 0.0 0.0 -12.9240110637 0.0 0.0 -12.9340110637 0.0 0.0 -12.9440110637 0.0 0.0 -12.9450332298 0.0 0.0 -12.9550332298 0.0 0.0 -12.9650332298 0.0 0.0 -12.9750332298 0.0 0.0 -12.9850332298 0.0 0.0 -12.9912966201 0.0 0.0 -13.0012966201 0.0 0.0 -13.0111217564 0.0 0.0 -13.0211217564 0.0 0.0 -13.0311217564 0.0 0.0 -13.0411217564 0.0 0.0 -13.0511217564 0.0 0.0 -13.058518393 0.0 0.0 -13.0613243872 0.0 0.0 -13.0713243872 0.0 0.0 -13.0813243872 0.0 0.0 -13.0889470195 0.0 0.0 -13.0984002151 0.0 0.0 -13.1049522566 0.0 0.0 -13.1118936381 0.0 0.0 -13.1201530836 0.0 0.0 -13.1212883995 0.0 0.0 -13.1312883995 0.0 0.0 -13.1347815121 0.0 0.0 -13.1411765089 0.0 0.0 -13.1452390309 0.0 0.0 -13.1504350697 0.0 0.0 -13.1578830195 0.0 0.0 -13.1593334014 0.0 0.0 -13.1630141409 0.0 0.0 -13.1663827473 0.0 0.0 -13.173818241 0.0 0.0 -13.1786603487 0.0 0.0 -13.1843068299 0.0 0.0 -13.1857449606 0.0 0.0 -13.190649336 0.0 0.0 -13.1941252729 0.0 0.0 -13.1970341804 0.0 0.0 -13.2070341804 0.0 0.0 -13.2170341804 0.0 0.0 -13.2226268595 0.0 0.0 -13.2258059476 0.0 0.0 -13.233045969 0.0 0.0 -13.2365433745 0.0 0.0 -13.239408358 0.0 0.0 -13.2407935909 0.0 0.0 -13.2426044408 0.0 0.0 -13.2459654441 0.0 0.0 -13.248668207 0.0 0.0 -13.2516452111 0.0 0.0 -13.2549277596 0.0 0.0 -13.2589563655 0.0 0.0 -13.2638357668 0.0 0.0 -13.2703797968 0.0 0.0 -13.2769750415 0.0 0.0 -13.2845711666 0.0 0.0 -13.293496414 0.0 0.0 -13.3016045139 0.0 0.0 -13.3081523163 0.0 0.0 -13.3158733935 0.0 0.0 -13.3220220458 0.0 0.0 -13.3320220458 0.0 0.0 -13.3407756007 0.0 0.0 -13.3455941164 0.0 0.0 -13.3555941164 0.0 0.0 -13.3655941164 0.0 0.0 -13.3698198486 0.0 0.0 -13.3705474284 0.0 0.0 -13.3761291902 0.0 0.0 -13.3811152242 0.0 0.0 -13.3869139587 0.0 0.0 -13.3887703161 0.0 0.0 -13.3906325412 0.0 0.0 -13.3949871768 0.0 0.0 -13.401054756 0.0 0.0 -13.4050040322 0.0 0.0 -13.4127702128 0.0 0.0 -13.414880716 0.0 0.0 -13.4155093515 0.0 0.0 -13.416397839 0.0 0.0 -13.4181390748 0.0 0.0 -13.4222180191 0.0 0.0 -13.4285459195 0.0 0.0 -13.436537455 0.0 0.0 -13.4454680914 0.0 0.0 -13.4510464225 0.0 0.0 -13.4567533235 0.0 0.0 -13.4572533235 0.0 0.0 -13.4584463641 0.0 0.0 -13.4598204109 0.0 0.0 -13.4612218106 0.0 0.0 -13.463815711 0.0 0.0 -13.4643583714 0.0 0.0 -13.4648583714 0.0 0.0 -13.4653583714 0.0 0.0 -13.4658811583 0.0 0.0 -13.4663811583 0.0 0.0 -13.4671744635 0.0 0.0 -13.4684677623 0.0 0.0 -13.4702117725 0.0 0.0 -13.4723436394 0.0 0.0 -13.4764828955 0.0 0.0 -13.4799536857 0.0 0.0 -13.4834363104 0.0 0.0 -13.4884340403 0.0 0.0 -13.4937977679 0.0 0.0 -13.4942977679 0.0 0.0 -13.5016879133 0.0 0.0 -13.5064805421 0.0 0.0 -13.5102903852 0.0 0.0 -13.516051799 0.0 0.0 -13.5181318052 0.0 0.0 -13.5193124596 0.0 0.0 -13.5223220101 0.0 0.0 -13.529137323 0.0 0.0 -13.5327395016 0.0 0.0 -13.5356478672 0.0 0.0 -13.5410440067 0.0 0.0 -13.550065284 0.0 0.0 -13.5600400686 0.0 0.0 -13.5672282462 0.0 0.0 -13.569091279 0.0 0.0 -13.5735524435 0.0 0.0 -13.5781736196 0.0 0.0 -13.5798937672 0.0 0.0 -13.5831393382 0.0 0.0 -13.5894666936 0.0 0.0 -13.5931290234 0.0 0.0 -13.5960458695 0.0 0.0 -13.6007560511 0.0 0.0 -13.6033247924 0.0 0.0 -13.6045698758 0.0 0.0 -13.6078981274 0.0 0.0 -13.6090828145 0.0 0.0 -13.611460923 0.0 0.0 -13.6154373335 0.0 0.0 -13.6205341758 0.0 0.0 -13.6215977641 0.0 0.0 -13.6282335346 0.0 0.0 -13.6363384825 0.0 0.0 -13.6449911249 0.0 0.0 -13.6533001196 0.0 0.0 -13.6576857469 0.0 0.0 -13.6637830501 0.0 0.0 -13.6731544494 0.0 0.0 -13.6769013166 0.0 0.0 -13.6797558122 0.0 0.0 -13.6840042427 0.0 0.0 -13.6886724887 0.0 0.0 -13.6936999404 0.0 0.0 -13.6971741414 0.0 0.0 -13.6983502205 0.0 0.0 -13.7049431181 0.0 0.0 -13.7138571717 450.682696899 0.0 -13.7184634732 1235.33393031 0.0 -13.7198168124 2923.47811965 0.0 -13.7228040039 3244.32284521 0.0 -13.7254987747 3682.14694322 0.0 -13.7289213285 3625.04286842 0.0 -13.7337005682 3233.22159245 0.0 -13.7389159244 2929.21438753 0.0 -13.7394159244 327.210489169 0.0 -13.7407329134 -478.285922735 0.0 -13.7431543477 -660.64446644 0.0 -13.7471504408 -660.913311235 0.0 -13.7521879183 -532.880815067 0.0 -13.7542210905 -87.5152678049 0.0 -13.754778994 828.296085476 0.0 -13.7562443552 1294.12816033 0.0 -13.7597016818 1442.52584089 0.0 -13.7679487683 1316.82459235 0.0 -13.7733956819 1268.85380363 0.0 -13.7780275219 1129.69070013 0.0 -13.7832653324 931.525467635 1.78622557126 -13.7858373658 575.056806198 2.07307880596 -13.7877855711 247.018676498 2.02954432039 -13.7916050333 170.893509925 0.0 -13.7974611563 215.537321341 0.0 -13.8034782166 289.032308752 0.0 -13.8127931619 430.336331125 0.0 -13.8227931619 670.960298122 0.0 -13.8315362361 746.292943352 0.0 -13.8351128161 648.950686621 0.0 -13.8393907518 581.105041106 0.0 -13.8493907518 518.837900708 1.95145639757 -13.8593907518 484.95280215 3.33972436047 -13.8693907518 465.332705479 0.0 -13.8793907518 446.809351974 0.0 -13.8850778683 414.455458536 0.0 -13.8908620585 428.657618667 0.0 -13.8954281215 498.309949432 0.0 -13.9030185948 573.58770117 0.0 -13.9130185948 655.395946013 0.0 -13.9230185948 721.877679849 0.0 -13.9258947852 779.552441821 0.0 -13.9268086939 872.499161112 0.0 -13.9322877074 894.717633411 0.0 -13.9422877074 909.033105914 0.0 -13.9522877074 904.009948591 0.0 -13.9573807885 868.791091499 0.0 -13.9627257471 826.429163331 0.0 -13.9688029135 787.577124067 0.0 -13.9697479059 560.346111706 0.0 -13.9761043191 533.624768071 0.0 -13.9824981289 540.115444097 0.0 -13.9864974918 567.881884667 0.0 -13.9893138637 615.216084948 0.0 -13.9919151479 669.405475511 0.0 -13.9949623443 719.34645166 5.33793668426 -14.0015470854 750.872390977 3.08334121806 -14.0115470854 780.046125158 0.766868231551 -14.0215470854 816.813118027 0.0 -14.0220470854 1201.45586958 0.0 -14.0225470854 1445.34901054 0.0 -14.0235185473 1541.44163222 0.0 -14.0294617882 1549.02448315 1.90918144705 -14.03095674 1444.49907775 2.51767753932 -14.0394723355 1389.51398273 1.64963853303 -14.0434118917 1222.55280687 1.79726631321 -14.0509336293 1082.91063248 0.0 -14.057944086 928.761981511 0.0 -14.0636232891 780.063831023 0.0 -14.0670805847 582.076537591 0.0 -14.0712372177 439.571431331 0.0 -14.0731936147 191.170950945 0.0 -14.0742204228 -166.046768845 0.0 -14.0781778506 -189.669518673 0.0 -14.0811243333 -165.76863221 0.0 -14.086715603 -106.23684722 0.0 -14.0900262776 39.1661483652 0.0 -14.0956631963 190.238089676 0.0 -14.102788159 351.029174987 0.0 -14.1111410634 549.210135303 0.0 -14.1143365175 882.625290272 0.0 -14.1189218654 1187.81688261 0.0 -14.1244689656 1326.26192744 0.0 -14.1291590544 1400.6024631 0.0 -14.135340924 1393.190159 0.0 -14.1396777179 1377.5044678 0.0 -14.1443584911 1288.07473744 0.0 -14.1451880034 917.513373344 0.0 -14.1462026866 824.191714615 0.0 -14.1500617325 693.610829793 0.0 -14.1556658862 582.274811298 0.0 -14.160838305 499.850713484 0.0 -14.1658602169 450.124303583 0.0 -14.1697338701 427.696756164 0.0 -14.1797242353 428.71168565 0.0 -14.1811446784 403.587229239 0.0 -14.1899898957 374.611681743 0.0 -14.1949254689 405.386758874 0.0 -14.2018070927 460.268252237 0.0 -14.2087272187 488.8939566 0.0 -14.2117000614 528.795071972 0.0 -14.2149997331 556.3074345 0.0 -14.2188795426 590.345340594 0.0 -14.2231996663 593.881558621 0.0 -14.2279483155 594.051429015 0.0 -14.2318319538 608.03170934 0.0 -14.235650993 621.453690446 0.0 -14.241541617 621.463446077 0.0 -14.2461172601 639.777092353 0.0 -14.2501265071 637.053963181 0.0 -14.2528414947 617.254288576 0.0 -14.2562407544 599.367337922 0.0 -14.2599465193 592.890993553 0.0 -14.2646177366 572.78724122 0.0 -14.2702250954 555.668363154 0.0 -14.2775976578 547.97351919 0.0 -14.2804783337 536.481619837 0.0 -14.2833649847 531.267560009 0.0 -14.2858758198 521.865879758 0.0 -14.288546162 512.163516692 0.0 -14.293919571 502.6212589 0.0 -14.2994924055 499.804864209 0.0 -14.3060699042 495.509343725 0.0 -14.3094783547 503.146528073 0.0 -14.3125289474 522.88611184 0.0 -14.3134295646 570.868573178 0.0 -14.3162252117 554.093583989 0.0 -14.3223563358 551.427419027 0.0 -14.3253996117 552.483967679 0.0 -14.3262628311 513.999008709 0.0 -14.3356322139 555.851475093 0.0 -14.3381486899 516.001014795 0.0 -14.3423386996 543.670540462 0.0 -14.3466138578 550.827253039 0.0 -14.3524857741 540.107048238 0.0 -14.3591522807 528.285744167 0.0 -14.3634899164 514.397979151 0.0 -14.3663298615 491.730502847 0.0 -14.3710162825 480.340732052 0.0 -14.3769291741 474.879180491 0.0 -14.3821591779 470.515955312 0.0 -14.3869137952 461.025450688 0.0 -14.3948666262 451.435124957 0.0 -14.3993749249 443.309963636 0.0 -14.4059508925 434.647731567 0.0 -14.4151814745 423.088661829 0.0 -14.4211172079 417.458234635 0.0 -14.4311172079 407.550675509 0.0 -14.4341185563 409.482242623 0.0 -14.4358296238 415.887467204 0.0 -14.4378604374 417.6587619 0.0 -14.4440411097 417.448180545 0.0 -14.448837152 414.124367924 0.0 -14.4566342058 403.583117262 0.0 -14.4621768997 399.808126857 0.0 -14.4650905302 399.787136266 0.0 -14.4689000681 396.817788799 0.0 -14.4722410332 395.793722269 0.0 -14.4748054964 395.420071074 0.0 -14.4774339658 395.180561499 0.0 -14.4817757126 390.433788956 0.0 -14.4822757126 388.583896289 0.0 -14.4885624435 381.11222524 0.0 -14.4912299171 378.591771084 0.0 -14.4917299171 390.989172799 0.0 -14.4924679945 396.455821715 0.0 -14.4938821346 391.794747134 0.0 -14.496375981 385.238645816 0.0 -14.5001331325 375.078279921 0.0 -14.5035054379 367.124038622 0.0 -14.505749417 360.973038699 0.0 -14.5076750421 354.404061548 0.0 -14.5096454371 350.88368431 0.0 -14.5119665871 349.329379963 0.0 -14.5138221639 345.449202161 0.0 -14.5171888305 342.925474893 0.0 -14.5189809972 343.206821689 0.0 -14.5211832361 341.068152405 0.0 -14.5246577652 337.9992005 0.0 -14.5274285456 334.713120236 0.0 -14.5308813359 330.952403517 0.0 -14.5339454614 327.748634688 0.0 -14.5368752566 324.484850136 0.0 -14.5395452296 321.178939756 0.0 -14.5426935761 316.320086726 0.0 -14.5450967294 312.372740951 0.0 -14.5477406065 307.235261664 0.0 -14.5522381487 300.233874178 0.0 -14.5589344425 289.352312697 0.0 -14.5634027861 280.878256837 0.0 -14.5676056631 272.723620113 0.0 -14.5725385188 263.625925131 0.0 -14.578346622 253.32260498 0.0 -14.584039774 241.741926254 0.0 -14.5913604054 228.717093841 0.0 -14.6013604054 210.935308159 0.0 -14.6040167437 203.366907648 0.0 -14.6055919322 207.838509687 0.0 -14.607675708 211.007363068 0.0 -14.6136172414 201.294917075 0.0 -14.6193505854 191.098781433 0.0 -14.6228800437 185.87956787 0.0 -14.6257932948 177.620044875 0.0 -14.6283087624 174.556984988 0.0 -14.6307913893 170.651342198 0.0 -14.6343314384 164.317579692 0.0 -14.6393065544 154.414448195 0.0 -14.6410286745 149.017302472 0.0 -14.6457571209 141.928509991 0.0 -14.6522651423 130.270234122 0.0 -14.6570647972 120.580127038 0.0 -14.6617501939 114.846198968 0.0 -14.6655410788 109.639038086 0.0 -14.6667153775 107.607183211 0.0 -14.6685141 108.448192589 0.0 -14.6707723547 103.91132058 0.0 -14.6736318323 98.7212688087 0.0 -14.6772425274 92.3458047097 0.0 -14.6816846794 83.2602498463 0.0 -14.6865794621 73.9359144444 0.0 -14.6921384679 66.021379964 0.0 -14.6983793851 58.365582193 0.0 -14.7033044413 54.3741877731 0.0 -14.7083793498 51.4068858192 0.0 -14.7136790175 45.1587299404 0.0 -14.7179988264 38.8562961401 0.0 -14.7236701381 32.1098120778 0.0 -14.7292525103 25.695028934 0.0 -14.7319850707 21.9907195711 0.0 -14.7384821586 8.46840816999 0.0 -14.7398985678 -11.5278008931 0.0 -14.7454349801 -18.9557353991 0.0 -14.7488889301 -22.567372988 0.0 -14.7537043078 -32.70394744 0.0 -14.7603050876 -45.5088786897 0.0 -14.7660646088 -53.6376202028 0.0 -14.7719741633 -57.7288258361 0.0 -14.7765917419 0.0 0.0 -14.7829041032 0.0 0.0 -14.7879429173 0.0 0.0 -14.7979429173 0.0 0.0 -14.8012783802 0.0 0.0 -14.8112783802 0.0 0.0 -14.817001181 0.0 0.0 -14.8214442198 0.0 0.0 -14.8313178682 0.0 0.0 -14.8409648829 0.0 0.0 -14.8509648829 0.0 0.0 -14.8609648829 0.0 0.0 -14.8695868601 0.0 0.0 -14.8734430899 0.0 0.0 -14.8834430899 0.0 0.0 -14.8934430899 0.0 0.0 -14.9034430899 0.0 0.0 -14.9134430899 0.0 0.0 -14.9234430899 0.0 0.0 -14.9303503184 0.0 0.0 -14.9395386614 0.0 0.0 -14.9439010337 0.0 0.0 -14.9484798911 0.0 0.0 -14.9531616717 0.0 0.0 -14.9598569251 0.0 0.0 -14.9698569251 0.0 0.0 -14.9798315951 0.0 0.0 -14.9898315951 0.0 0.0 -14.9984589029 0.0 0.0 -15.0058470854 0.0 0.0 -15.0158470854 0.0 0.0 -15.0176495875 0.0 0.0 -15.0276495875 0.0 0.0 -15.032698796 0.0 0.0 -15.042698796 0.0 0.0 -15.0466565025 0.0 0.0 -15.0492745376 0.0 0.0 -15.0592745376 0.0 0.0 -15.0684645298 0.0 0.0 -15.0745717511 0.0 0.0 -15.076321146 0.0 0.0 -15.0847633971 0.0 0.0 -15.0917003041 0.0 0.0 -15.0940666896 0.0 0.0 -15.0970512747 0.0 0.0 -15.1011311947 0.0 0.0 -15.1063769142 0.0 0.0 -15.1074247437 0.0 0.0 -15.1107174403 0.0 0.0 -15.1169155309 0.0 0.0 -15.1267351157 0.0 0.0 -15.1329177674 0.0 0.0 -15.1397733033 0.0 0.0 -15.1454701983 0.0 0.0 -15.1528403837 0.0 0.0 -15.1604097668 0.0 0.0 -15.1631083025 0.0 0.0 -15.165274277 0.0 0.0 -15.168546282 0.0 0.0 -15.1725766611 0.0 0.0 -15.1775073177 0.0 0.0 -15.1849795941 0.0 0.0 -15.1922999203 0.0 0.0 -15.1986074877 0.0 0.0 -15.2019074519 0.0 0.0 -15.2119074519 0.0 0.0 -15.2148011224 0.0 0.0 -15.2245482163 0.0 0.0 -15.2266837306 0.0 0.0 -15.2271837306 0.0 0.0 -15.2353146286 0.0 0.0 -15.244511235 0.0 0.0 -15.2474772291 0.0 0.0 -15.2557110601 0.0 0.0 -15.2630498963 0.0 0.0 -15.2730498963 0.0 0.0 -15.2808748723 0.0 0.0 -15.2908748723 0.0 0.0 -15.2926531021 0.0 0.0 -15.3018701277 0.0 0.0 -15.3104672561 0.0 0.0 -15.3160391454 0.0 0.0 -15.3260391454 0.0 0.0 -15.3331130625 0.0 0.0 -15.3431130625 0.0 0.0 -15.3531130625 0.0 0.0 -15.3595176152 0.0 0.0 -15.3695176152 0.0 0.0 -15.3794379692 0.0 0.0 -15.3838135626 0.0 0.0 -15.3848999924 0.0 0.0 -15.3948999924 0.0 0.0 -15.4032488635 0.0 0.0 -15.4082603614 0.0 0.0 -15.4182603614 0.0 0.0 -15.4246033191 0.0 0.0 -15.4270489838 0.0 0.0 -15.4325729964 0.0 0.0 -15.437772457 0.0 0.0 -15.4413237685 0.0 0.0 -15.4448507082 0.0 0.0 -15.4476429434 0.0 0.0 -15.4484267785 0.0 0.0 -15.4508258635 0.0 0.0 -15.4513562966 0.0 0.0 -15.4565932265 0.0 0.0 -15.4580534133 0.0 0.0 -15.4626272243 0.0 0.0 -15.4673682892 0.0 0.0 -15.4720686517 0.0 0.0 -15.475368704 0.0 0.0 -15.4802991083 0.0 0.0 -15.4832214197 0.0 0.0 -15.4860994802 0.0 0.0 -15.4904402535 0.0 0.0 -15.4954835561 0.0 0.0 -15.5018102761 0.0 0.0 -15.5056185903 0.0 0.0 -15.5123803934 0.0 0.0 -15.5197688324 0.0 0.0 -15.5211177453 0.0 0.0 -15.5264504807 0.0 0.0 -15.532370116 0.0 0.0 -15.5367769551 0.0 0.0 -15.5418872348 0.0 0.0 -15.5477215238 0.0 0.0 -15.5516976512 0.0 0.0 -15.5549528638 0.0 0.0 -15.558896687 0.0 0.0 -15.5658581322 0.0 0.0 -15.5717716155 0.0 0.0 -15.5763105806 0.0 0.0 -15.5795995287 0.0 0.0 -15.5835172352 0.0 0.0 -15.5878718027 0.0 0.0 -15.5915285306 0.0 0.0 -15.5967178885 0.0 0.0 -15.5989492462 0.0 0.0 -15.6019093859 0.0 0.0 -15.6040036552 0.0 0.0 -15.607314096 0.0 0.0 -15.61378568 0.0 0.0 -15.6159772707 0.0 0.0 -15.6206088261 0.0 0.0 -15.6277097746 0.0 0.0 -15.6300917367 0.0 0.0 -15.6331441025 0.0 0.0 -15.6353788745 2131.38735982 0.0 -15.6394784099 1387.55727225 0.0 -15.6434454248 1971.44108789 0.0 -15.64733136 1055.15337178 0.0 -15.651945832 1401.30447764 0.0 -15.6543889761 1736.97696178 0.0 -15.6587268006 1583.57470366 0.0 -15.6630181178 1530.56673141 0.0 -15.6654506912 1588.95576191 0.0 -15.6698593046 1600.02319539 0.0 -15.6735965538 1692.37495253 0.0 -15.6772315474 1765.56624356 0.0 -15.6781094706 2405.88527626 0.0 -15.6789768687 2465.95986457 0.0 -15.6816636413 2216.30712217 0.0 -15.6842691046 2060.70600937 0.0 -15.688706236 1790.67343759 0.0 -15.6944707737 1503.85296373 0.0 -15.6994547541 1287.34440491 0.0 -15.7024177995 1043.46695791 0.0 -15.7092665736 820.885335596 0.0 -15.7100203245 153.130710829 0.0 -15.7146378475 95.3619382532 0.0 -15.7195721493 116.702892617 0.0 -15.7233742333 182.462539438 0.0 -15.7294302411 284.541940718 0.0 -15.736217926 378.179703794 0.0 -15.7439888178 475.100230922 3.39391536621 -15.7522119194 532.358962869 0.0 -15.7598476225 559.716855333 2.27196590924 -15.7698476225 588.615188238 0.0 -15.7791612652 605.917911158 0.0 -15.7891612652 606.205167578 4.41541469436 -15.7916779478 562.810543196 -2.72458705226 -15.794605212 534.98777301 4.04734133672 -15.8030475535 541.160377105 -8.49685541842 -15.8065228824 524.621651673 -28.756858034 -15.8080408471 476.390709153 -46.8993719609 -15.8102402945 446.511430082 116.230737471 -15.8134227401 435.164574393 195.912043274 -15.8234227401 447.847114248 53.9678302294 -15.8303848303 461.858871531 76.8377153867 -15.8339786026 474.475705339 36.857533439 -15.8362905528 484.357519879 40.5126455116 -15.8437576803 499.545465743 55.7363158966 -15.851769754 525.965321007 26.0930798162 -15.8614317674 551.441995012 31.6568944382 -15.8714317674 580.381033602 -9.98647285478 -15.8720778935 734.71554383 -2.96757665563 -15.8733388992 750.296727713 -4.68366910701 -15.8812855211 751.84073403 0.0 -15.8856247662 749.636222102 0.0 -15.8956247662 745.029587414 0.0 -15.9056247662 730.65376996 0.0 -15.9156247662 710.217978858 21.490617082 -15.9256247662 689.915534313 9.10443565566 -15.935349219 672.429158178 -6.6439678862 -15.942356427 657.248962375 22.314071935 -15.952356427 663.049717275 31.2977243538 -15.962356427 691.481553951 15.7697041424 -15.9666181048 735.664370973 8.78163254926 -15.9696630727 787.479433904 -0.663345027158 -15.9732529598 822.525421793 0.0 -15.9794204047 848.730834579 0.0 -15.9868032715 888.466680491 0.0 -15.9932897066 912.847628666 1.1073688812 -15.9990579178 959.139732584 0.915012402456 -16.0037165399 986.891542468 0.0 -16.010261597 979.018210063 0.0 -16.0167643185 985.365164101 0.0 -16.0193715094 1001.569256 0.0 -16.0215923037 965.669428273 0.0 -16.0278761144 952.910909136 0.0 -16.0348774084 932.765577022 0.0 -16.0413113088 906.741694812 0.0 -16.0485439163 868.636775531 0.0 -16.050143667 728.433662863 0.0 -16.0583234382 702.634373295 0.0 -16.065977875 669.441107928 0.0 -16.0716300453 643.715780035 0.0 -16.0799552519 640.271124602 0.0 -16.0854050685 653.995452901 0.0 -16.0894650125 704.991027432 0.0 -16.0932998609 724.920752799 0.0 -16.0988176188 688.014740215 0.0 -16.1029152108 712.076856701 0.0 -16.1061058182 736.434003846 0.0 -16.1081399176 754.865977449 0.0 -16.1121595642 942.149929827 0.0 -16.1163025642 855.917829515 0.0 -16.1233140155 746.52158777 0.0 -16.128896573 662.353279586 0.0 -16.1368755965 612.204578896 0.0 -16.1436470886 604.631869453 0.0 -16.1477921137 552.348051937 0.0 -16.1544902847 506.40048247 0.0 -16.1577367955 462.513357387 0.0 -16.1609231694 405.38645097 0.0 -16.1634575052 366.352590295 0.0 -16.1649950917 366.189149219 0.0 -16.1688769947 403.389117207 0.0 -16.1734919511 392.273639254 0.0 -16.1806845365 381.175499563 0.0 -16.1858880073 413.26728364 0.0 -16.1879696445 472.571745492 0.0 -16.1906091816 422.271769242 0.0 -16.1928326723 397.608573589 0.0 -16.195871789 401.921361731 0.0 -16.2036192496 394.307814254 0.0 -16.208236423 402.748825247 0.0 -16.2129363167 384.035639179 0.0 -16.2134363167 379.399040649 0.0 -16.2139363167 410.035594177 0.0 -16.2149924158 343.877029363 0.0 -16.2193525486 375.893190319 0.0 -16.221724815 674.109272464 0.0 -16.2229107642 893.447970951 0.0 -16.2248060122 1018.44867789 0.0 -16.2311158166 937.858454744 0.0 -16.2382610451 740.797344978 0.0 -16.2400360771 459.044814173 0.0 -16.2447616367 431.797023266 0.0 -16.2487266516 361.93083655 0.0 -16.2565370828 305.654387844 0.0 -16.2628700922 281.014578918 0.0 -16.2705508844 278.231433977 0.0 -16.2754929022 325.567037998 0.0 -16.2786090853 365.82281639 0.0 -16.2854275403 411.652812349 0.0 -16.2920424131 432.371212489 0.0 -16.2976238508 451.107519227 0.0 -16.3005166912 493.993713556 0.0 -16.3100087532 491.728009984 0.0 -16.3184202824 489.631801878 0.0 -16.3269530111 481.286906334 0.0 -16.3295167144 501.032058377 0.0 -16.3310632836 482.673374799 0.0 -16.3394841177 454.641457934 0.0 -16.3494841177 425.54212288 0.0 -16.3594841177 409.890232362 0.0 -16.3694841177 380.031768787 0.0 -16.3743335632 372.624288848 0.0 -16.3765196412 358.241133813 0.0 -16.3865196412 334.030249974 0.0 -16.3933037352 312.752797794 0.0 -16.3995894311 294.280993509 0.0 -16.4040937647 283.688913731 0.0 -16.4081409483 278.849066162 0.0 -16.4099442108 275.468778195 0.0 -16.4115141926 270.790815772 0.0 -16.4186213423 262.265672729 0.0 -16.4274866992 253.19054009 0.0 -16.4304567228 258.233142004 0.0 -16.4381169553 253.076623103 0.0 -16.4391448783 299.483265653 0.0 -16.4399319123 359.317369997 0.0 -16.4404319123 413.976033156 0.0 -16.4409319123 441.202182248 0.0 -16.4414319123 450.626876678 0.0 -16.4438948119 437.896664326 0.0 -16.4444819662 402.142686469 0.0 -16.4540357781 370.760738005 0.0 -16.4588634975 348.030305932 0.0 -16.4614727621 320.537689934 0.0 -16.46475004 295.671136875 0.0 -16.4670454009 269.992183264 0.0 -16.4714387862 247.391261436 0.0 -16.4749927552 218.94760265 0.0 -16.4815959389 193.789678021 0.0 -16.4844553623 161.73661546 0.0 -16.4896554434 145.895010391 0.0 -16.4996554434 135.991694286 0.0 -16.5089404924 133.751190244 0.0 -16.5169408341 131.521652121 0.0 -16.5244106102 124.711001809 0.0 -16.5318908722 119.30997627 0.0 -16.5384926571 113.861699088 0.0 -16.5427249113 111.665530387 0.0 -16.5440471413 120.236054674 0.0 -16.5472415563 113.089182896 0.0 -16.5494007344 109.577177312 0.0 -16.5527980874 105.136146998 0.0 -16.5563316536 100.188738103 0.0 -16.5587288688 97.6716213624 0.0 -16.56099592 95.9739577857 0.0 -16.5647330271 91.4391663633 0.0 -16.5674221521 87.2124573124 0.0 -16.5710408525 77.2148166701 0.0 -16.5763021492 53.7993308152 0.0 -16.5817492888 47.050726898 0.0 -16.5866052834 40.4858797282 0.0 -16.5923257541 32.9785940827 0.0 -16.5937394756 30.7648140078 0.0 -16.5968666837 26.8615678713 0.0 -16.6008767237 18.3807102119 0.0 -16.6057557319 9.66087961934 0.0 -16.6082544905 8.85859417771 0.0 -16.6113682985 6.86593776419 0.0 -16.6138242405 4.3464923864 0.0 -16.6167995354 0.874735675668 0.0 -16.6204671126 -3.24233097817 0.0 -16.6245666373 -7.68202701417 0.0 -16.6290920378 -11.8624895723 0.0 -16.6343299008 -18.2260317739 0.0 -16.6381604179 -24.1357613753 0.0 -16.6416252064 -26.7667093123 0.0 -16.645567959 -37.4608623862 0.0 -16.6510275921 -50.9690773624 0.0 -16.6561916443 -64.2952800659 0.0 -16.6607312925 -74.3410322243 0.0 -16.6660740121 -80.9494409943 0.0 -16.6702538438 0.0 0.0 -16.6750659688 0.0 0.0 -16.6798469167 0.0 0.0 -16.685899396 0.0 0.0 -16.6936383789 0.0 0.0 -16.7019235497 0.0 0.0 -16.708066365 0.0 0.0 -16.7174427364 0.0 0.0 -16.7242632461 0.0 0.0 -16.7323766562 0.0 0.0 -16.7370398089 0.0 0.0 -16.7465844596 0.0 0.0 -16.7565844596 0.0 0.0 -16.7665844596 0.0 0.0 -16.7765844596 0.0 0.0 -16.7865844596 0.0 0.0 -16.7965844596 0.0 0.0 -16.8065844596 0.0 0.0 -16.8165844596 0.0 0.0 -16.8265844596 0.0 0.0 -16.8365844596 0.0 0.0 -16.8462030638 0.0 0.0 -16.8474420116 0.0 0.0 -16.8480614857 0.0 0.0 -16.8580614857 0.0 0.0 -16.8680614857 0.0 0.0 -16.8762923662 0.0 0.0 -16.8862923662 0.0 0.0 -16.8962923662 0.0 0.0 -16.9062923662 0.0 0.0 -16.9149563964 0.0 0.0 -16.9196032542 0.0 0.0 -16.9202680254 0.0 0.0 -16.9280955273 0.0 0.0 -16.9360812544 0.0 0.0 -16.942749866 0.0 0.0 -16.9496261047 0.0 0.0 -16.9565071592 0.0 0.0 -16.9630875051 0.0 0.0 -16.9698481155 0.0 0.0 -16.9759878669 0.0 0.0 -16.9821098716 0.0 0.0 -16.9836884767 0.0 0.0 -16.9895631177 0.0 0.0 -16.9964422871 0.0 0.0 -17.0041229017 0.0 0.0 -17.011574362 0.0 0.0 -17.0168229843 0.0 0.0 -17.023815791 0.0 0.0 -17.0277637184 0.0 0.0 -17.0330711419 0.0 0.0 -17.0373107554 0.0 0.0 -17.0412879652 0.0 0.0 -17.0450449607 0.0 0.0 -17.0495594485 0.0 0.0 -17.0544684864 0.0 0.0 -17.0579771247 0.0 0.0 -17.0633426945 0.0 0.0 -17.0690580718 0.0 0.0 -17.0736004426 0.0 0.0 -17.0766795673 0.0 0.0 -17.0810218772 0.0 0.0 -17.0853953386 0.0 0.0 -17.0871923687 0.0 0.0 -17.089986079 0.0 0.0 -17.0942713401 0.0 0.0 -17.0979580311 0.0 0.0 -17.1025019056 0.0 0.0 -17.1069681718 0.0 0.0 -17.1120290229 0.0 0.0 -17.1157846644 0.0 0.0 -17.1203927973 0.0 0.0 -17.1270312306 0.0 0.0 -17.1309304924 0.0 0.0 -17.1339575889 0.0 0.0 -17.1365651562 0.0 0.0 -17.1413798819 0.0 0.0 -17.1457561982 0.0 0.0 -17.1523919 0.0 0.0 -17.1591443284 0.0 0.0 -17.1604036821 0.0 0.0 -17.1625117299 0.0 0.0 -17.1647462015 0.0 0.0 -17.1675255689 0.0 0.0 -17.1720687126 0.0 0.0 -17.1729206055 0.0 0.0 -17.1783137377 0.0 0.0 -17.1841243948 0.0 0.0 -17.1891597648 0.0 0.0 -17.1909648002 0.0 0.0 -17.1914648002 0.0 0.0 -17.1928405175 0.0 0.0 -17.1937346064 0.0 0.0 -17.1969520483 0.0 0.0 -17.2022994395 0.0 0.0 -17.2076669458 0.0 0.0 -17.2124768733 0.0 0.0 -17.221988742 0.0 0.0 -17.22869347 0.0 0.0 -17.2346268288 0.0 0.0 -17.2413088102 0.0 0.0 -17.2513088102 0.0 0.0 -17.2608710556 0.0 0.0 -17.2708710556 0.0 0.0 -17.2808710556 0.0 0.0 -17.2846692546 0.0 0.0 -17.289198484 0.0 0.0 -17.2931734167 0.0 0.0 -17.299390248 0.0 0.0 -17.306395617 0.0 0.0 -17.3149160608 0.0 0.0 -17.320982717 0.0 0.0 -17.3301373446 0.0 0.0 -17.3401373446 0.0 0.0 -17.3414311735 0.0 0.0 -17.3419311735 0.0 0.0 -17.3430692374 0.0 0.0 -17.349743257 0.0 0.0 -17.3581618745 0.0 0.0 -17.362745557 0.0 0.0 -17.3723338913 0.0 0.0 -17.3749015903 0.0 0.0 -17.3848525324 0.0 0.0 -17.3911995298 0.0 0.0 -17.4011995298 0.0 0.0 -17.4110352839 0.0 0.0 -17.4210352839 0.0 0.0 -17.4269946867 0.0 0.0 -17.4326065681 0.0 0.0 -17.4367478925 0.0 0.0 -17.4412805745 0.0 0.0 -17.4452355048 0.0 0.0 -17.4484094808 0.0 0.0 -17.4509188087 0.0 0.0 -17.4536348816 0.0 0.0 -17.4550747333 0.0 0.0 -17.4574034288 0.0 0.0 -17.4608678389 0.0 0.0 -17.4651984597 0.0 0.0 -17.4689204447 0.0 0.0 -17.4748629834 0.0 0.0 -17.4796691228 0.0 0.0 -17.4851813244 0.0 0.0 -17.4887994153 0.0 0.0 -17.491140236 0.0 0.0 -17.4939366012 0.0 0.0 -17.4972275211 0.0 0.0 -17.503021631 0.0 0.0 -17.5078963543 0.0 0.0 -17.5131561423 0.0 0.0 -17.5176862227 0.0 0.0 -17.5212447017 0.0 0.0 -17.5247606862 0.0 0.0 -17.5289766863 0.0 0.0 -17.5320423267 0.0 0.0 -17.5336750615 0.0 0.0 -17.5394890209 0.0 0.0 -17.5440032336 0.0 0.0 -17.550706185 668.650038246 0.0 -17.5557499786 727.924974474 0.0 -17.5578138107 1524.69991683 0.0 -17.5611043986 1725.1734552 0.0 -17.5660528262 1963.64121757 0.0 -17.5709831845 2080.74773433 0.0 -17.5742094279 2997.25495211 0.0 -17.579875122 2838.47167677 0.0 -17.5852060787 2445.88138617 0.0 -17.5890845419 2204.90715302 0.0 -17.591718047 1919.18301833 0.0 -17.5960382828 1493.8255313 0.0 -17.6007826427 1126.3512626 0.0 -17.6060789719 796.801326322 0.0 -17.6133000058 523.882309419 0.0 -17.6208671744 365.802889429 0.0 -17.6274653289 270.123287719 0.0 -17.6327474141 232.848700142 0.0 -17.6375824989 280.068932541 0.0 -17.6420459354 360.901546426 0.0 -17.6473321745 449.535859764 0.0 -17.6513285815 564.279161398 0.0 -17.6546810145 682.637073008 0.0 -17.6554059069 999.52468359 0.0 -17.6568510757 1079.48064153 0.0 -17.6598103197 1078.07049367 3.35210823489 -17.6646003297 1040.10083175 3.43390141485 -17.6682588665 964.482851442 0.0 -17.6746072432 889.338558859 0.0 -17.6780779582 765.552184262 0.0 -17.6880779582 697.001520011 0.0 -17.6939290162 599.088228652 0.0 -17.7036841589 558.944137571 0.0 -17.7117545131 529.411848862 0.0 -17.7186982035 512.482899851 0.0 -17.726884968 521.704487433 0.0 -17.7351876244 543.735735169 0.0 -17.7451876244 575.81760716 0.0 -17.7490042368 618.211957291 0.0 -17.7590042368 646.850750074 0.0 -17.7690042368 668.027527454 0.0 -17.7695894851 726.742929811 0.0 -17.7703834705 733.817447418 0.0 -17.7725115853 724.556125922 0.0 -17.7825115853 697.827864197 0.0 -17.7925115853 654.273658057 0.0 -17.8025115853 613.109376151 0.0 -17.8087607779 605.398454171 0.0 -17.8125909449 607.194874511 0.0 -17.817949339 635.537800995 0.0 -17.8256113843 700.915273275 0.0 -17.8327096433 795.161465363 0.0 -17.8427096433 868.377452447 0.0 -17.8524661165 941.035348763 0.0 -17.8624661165 987.909526819 0.0 -17.8724661165 994.489149405 0.0 -17.8809670122 1018.00530354 0.0 -17.8852541347 1024.30009017 0.0 -17.8952541347 1020.65479464 0.0 -17.8997351408 994.624550029 0.0 -17.9005141267 966.125613472 0.0 -17.9091078402 916.945638129 0.0 -17.9110043823 873.858728849 0.0 -17.9183041867 838.311361726 0.0 -17.9279064337 809.594391267 0.0 -17.9341772129 806.440197919 0.0 -17.9412341918 798.937481152 0.0 -17.9511829727 793.356047223 0.0 -17.9562091233 843.950206251 0.0 -17.9608258737 836.076107084 0.0 -17.9642702963 862.441926999 0.0 -17.9686139642 887.478979877 0.0 -17.9728523138 896.216388586 0.0 -17.9775205649 865.553769061 0.0 -17.9847266469 837.592329979 0.0 -17.9900571753 801.756001018 0.0 -17.9931249726 778.95058274 0.0 -17.9968554589 708.10796193 0.0 -17.9975033206 523.981358424 0.0 -17.9981568527 419.115860235 0.0 -18.0066582476 399.356965247 0.0 -18.0166311156 408.056896455 -0.763208194545 -18.0173774176 580.600611421 0.783083474558 -18.0183061871 686.676974276 -0.957620503444 -18.0195479348 748.03907092 -1.00461115884 -18.0295479348 703.110309371 0.0 -18.0305165524 640.229962872 0.0 -18.0320698344 699.351507208 0.0 -18.0340540085 667.896594297 0.0 -18.0384881508 614.610487797 0.0 -18.0424698348 577.564308917 0.0 -18.0464664709 551.416772446 0.0 -18.0512804013 505.1001081 0.0 -18.0569686611 524.6795595 0.0 -18.0635779657 511.101808516 0.0 -18.0713333978 473.260167758 0.0 -18.0803042287 465.946392707 0.0 -18.085587688 444.99238152 0.0 -18.0954162112 437.515143603 0.0 -18.0997678975 428.732008577 0.0 -18.1038266837 424.532244488 0.0 -18.1062089141 420.5756967 0.0 -18.109638645 577.413053854 0.0 -18.1119050749 637.341871604 0.0 -18.1134304011 690.876547118 0.0 -18.1164289916 670.084211297 0.0 -18.1216252644 530.58227837 0.0 -18.1296040856 477.533683008 0.0 -18.1375895499 430.359426647 0.0 -18.1426989215 354.232965768 0.0 -18.1467391796 275.209317623 0.0 -18.1530261874 262.58897442 0.0 -18.1598715997 259.771937007 0.0 -18.1622794556 269.319414361 0.0 -18.1713398447 242.599969776 0.0 -18.1777466304 273.484761473 0.0 -18.1877466304 294.224799138 0.0 -18.1977466304 293.675732538 0.0 -18.2039681489 364.418614799 0.0 -18.2113535832 403.020282752 0.0 -18.2190901655 427.494828018 0.0 -18.2290901655 460.730443625 0.0 -18.236688803 471.393766459 0.0 -18.2389455861 514.980881045 0.0 -18.2413402343 527.808146803 0.0 -18.2513402343 508.272340269 0.0 -18.2613402343 471.860420503 0.0 -18.269349135 427.621181156 0.0 -18.2731812728 363.73903537 0.0 -18.2784970853 352.658521222 0.0 -18.2873815267 312.548413903 0.0 -18.2973815267 248.853956594 0.0 -18.3073815267 237.885636379 0.0 -18.310839647 234.175596581 0.0 -18.320421055 219.398171837 0.0 -18.3300992508 221.756392019 0.0 -18.3367601235 228.456457051 0.0 -18.3457716637 235.236006297 0.0 -18.3510258327 258.13310754 0.0 -18.3610258327 259.175138141 0.0 -18.3707005321 264.583546666 0.0 -18.3795398186 262.230375373 0.0 -18.3872438066 264.961998263 0.0 -18.3917245852 271.634600859 0.0 -18.395400762 270.757614123 0.0 -18.3986559658 272.741627462 0.0 -18.4024286206 268.970441495 0.0 -18.4071536335 260.859938376 0.0 -18.409718112 250.56800951 0.0 -18.4132215137 240.399817859 0.0 -18.4174642915 230.155847747 0.0 -18.4221900545 219.870847826 0.0 -18.4266421299 208.937081977 0.0 -18.4326515834 193.840020897 0.0 -18.436024095 177.182613824 0.0 -18.4379192693 157.924700769 0.0 -18.4397758634 143.954240164 0.0 -18.4419373777 138.385571959 0.0 -18.4449740717 134.503912173 0.0 -18.4480158076 130.714825739 0.0 -18.451456894 126.402190669 0.0 -18.4554822916 121.351217775 0.0 -18.4619388875 116.460782155 0.0 -18.4659777643 113.194539089 0.0 -18.4706930223 109.137280759 0.0 -18.474035238 107.102440745 0.0 -18.4786890839 102.161731592 0.0 -18.4805879972 100.062296564 0.0 -18.4822883113 104.141080606 0.0 -18.4846146481 103.688471134 0.0 -18.4872624372 100.703361461 0.0 -18.4894635108 96.6279275654 0.0 -18.4935828772 88.5227164086 0.0 -18.4970108471 81.7144463853 0.0 -18.501057352 72.0983774756 0.0 -18.5050825467 62.4649215054 0.0 -18.5087217494 52.6244878741 0.0 -18.5133035375 43.4201451496 0.0 -18.5167731635 34.5474862341 0.0 -18.5190901477 25.6795114657 0.0 -18.5218008682 19.1767329247 0.0 -18.5241896198 14.5603375614 0.0 -18.5261154147 14.7122994256 0.0 -18.5273008081 10.5675201501 0.0 -18.5315427271 4.48159208586 0.0 -18.5351149953 -2.4123108181 0.0 -18.539176072 -7.37447736011 0.0 -18.5440029282 -13.70362964 0.0 -18.5485893137 -18.628548137 0.0 -18.5526384709 -23.9512354491 0.0 -18.5580844377 -32.1147054655 0.0 -18.5651075935 -41.3555372895 0.0 -18.5718155221 -50.5715826354 0.0 -18.5771382086 -57.0718925538 0.0 -18.5833308403 -64.3014545467 0.0 -18.5896406704 -71.5511225811 0.0 -18.5972786829 0.0 0.0 -18.6044986489 0.0 0.0 -18.6135339664 0.0 0.0 -18.6225698453 0.0 0.0 -18.6268351585 0.0 0.0 -18.6358139307 0.0 0.0 -18.6457763798 0.0 0.0 -18.6554569805 0.0 0.0 -18.6598926216 0.0 0.0 -18.6698299851 0.0 0.0 -18.678182229 0.0 0.0 -18.688182229 0.0 0.0 -18.698182229 0.0 0.0 -18.708182229 0.0 0.0 -18.718182229 0.0 0.0 -18.728182229 0.0 0.0 -18.7329500036 0.0 0.0 -18.7373852188 0.0 0.0 -18.7403059906 0.0 0.0 -18.7503059906 0.0 0.0 -18.7565155388 0.0 0.0 -18.7584274691 0.0 0.0 -18.7684274691 0.0 0.0 -18.7691637879 0.0 0.0 -18.7748456924 0.0 0.0 -18.7776188156 0.0 0.0 -18.7876188156 0.0 0.0 -18.7968160104 0.0 0.0 -18.8051372664 0.0 0.0 -18.8117652206 0.0 0.0 -18.8205067482 0.0 0.0 -18.828342961 0.0 0.0 -18.8354893647 0.0 0.0 -18.8422789486 0.0 0.0 -18.8487076994 0.0 0.0 -18.8546263215 0.0 0.0 -18.860167067 0.0 0.0 -18.8654773098 0.0 0.0 -18.8710665985 0.0 0.0 -18.8768028092 0.0 0.0 -18.8818905817 0.0 0.0 -18.8871964526 0.0 0.0 -18.8922058331 0.0 0.0 -18.8968602722 0.0 0.0 -18.8989618568 0.0 0.0 -18.9014721734 0.0 0.0 -18.9050971094 0.0 0.0 -18.9093044816 0.0 0.0 -18.9118330728 0.0 0.0 -18.9156163408 0.0 0.0 -18.9196452995 0.0 0.0 -18.9231731361 0.0 0.0 -18.9268389472 0.0 0.0 -18.930079353 0.0 0.0 -18.9351695292 0.0 0.0 -18.9406469433 0.0 0.0 -18.9444711906 0.0 0.0 -18.947029801 0.0 0.0 -18.9520045753 0.0 0.0 -18.9565742068 0.0 0.0 -18.9609244495 0.0 0.0 -18.9630156211 0.0 0.0 -18.9644636174 0.0 0.0 -18.9669111303 0.0 0.0 -18.9735385553 0.0 0.0 -18.9795975109 0.0 0.0 -18.9853331387 0.0 0.0 -18.9898836508 0.0 0.0 -18.9932633471 0.0 0.0 -18.9977621769 0.0 0.0 -19.0014779968 0.0 0.0 -19.0059334597 0.0 0.0 -19.0107002344 0.0 0.0 -19.013239676 0.0 0.0 -19.0175288751 0.0 0.0 -19.0184457486 0.0 0.0 -19.0206779763 0.0 0.0 -19.022001139 0.0 0.0 -19.0261174021 0.0 0.0 -19.0333434834 0.0 0.0 -19.0400365962 0.0 0.0 -19.04481678 0.0 0.0 -19.0497213177 0.0 0.0 -19.0597213177 0.0 0.0 -19.0661499534 0.0 0.0 -19.0689875692 0.0 0.0 -19.0789875692 0.0 0.0 -19.0829260506 0.0 0.0 -19.0929260506 0.0 0.0 -19.0971064359 0.0 0.0 -19.1052627096 0.0 0.0 -19.1110428454 0.0 0.0 -19.1172750027 0.0 0.0 -19.1231844673 0.0 0.0 -19.1272478736 0.0 0.0 -19.1372478736 0.0 0.0 -19.1424566487 0.0 0.0 -19.1465033689 0.0 0.0 -19.1523034973 0.0 0.0 -19.1623034973 0.0 0.0 -19.1660313919 0.0 0.0 -19.1713321674 0.0 0.0 -19.1738853951 0.0 0.0 -19.1768551619 0.0 0.0 -19.1794707658 0.0 0.0 -19.183286934 0.0 0.0 -19.1874613897 0.0 0.0 -19.1941834745 0.0 0.0 -19.2041834745 0.0 0.0 -19.2048871738 0.0 0.0 -19.2107040383 0.0 0.0 -19.2158096387 0.0 0.0 -19.2190396193 0.0 0.0 -19.2290396193 0.0 0.0 -19.2338318449 0.0 0.0 -19.2346548962 0.0 0.0 -19.235680451 0.0 0.0 -19.2374361393 0.0 0.0 -19.2399754587 0.0 0.0 -19.2444674407 0.0 0.0 -19.2476790255 0.0 0.0 -19.2505884263 0.0 0.0 -19.2531566096 0.0 0.0 -19.2546390689 0.0 0.0 -19.2570354698 0.0 0.0 -19.2611692099 0.0 0.0 -19.2669107413 0.0 0.0 -19.2705444977 0.0 0.0 -19.2735116143 0.0 0.0 -19.2760158974 0.0 0.0 -19.2809582675 0.0 0.0 -19.2875371767 0.0 0.0 -19.2939797381 0.0 0.0 -19.2976684789 0.0 0.0 -19.3052306914 0.0 0.0 -19.3104585267 0.0 0.0 -19.3145772581 0.0 0.0 -19.3200857375 0.0 0.0 -19.3271805113 0.0 0.0 -19.3318558712 0.0 0.0 -19.3379690337 0.0 0.0 -19.3442310674 0.0 0.0 -19.3509991031 0.0 0.0 -19.3609991031 0.0 0.0 -19.3674285271 0.0 0.0 -19.3705682653 0.0 0.0 -19.3774617298 0.0 0.0 -19.3838246784 0.0 0.0 -19.3903313598 0.0 0.0 -19.3933862421 0.0 0.0 -19.3938862421 0.0 0.0 -19.4002712518 0.0 0.0 -19.4059657471 0.0 0.0 -19.4071843352 0.0 0.0 -19.4120563552 0.0 0.0 -19.4174767679 0.0 0.0 -19.4192539838 0.0 0.0 -19.4218703485 0.0 0.0 -19.4251892931 0.0 0.0 -19.4321908169 0.0 0.0 -19.4359447621 0.0 0.0 -19.438049475 1760.37479211 0.0 -19.4393302621 2111.01195464 0.0 -19.4434747114 1712.30988681 0.0 -19.4494121558 1656.13663886 0.0 -19.4551826191 1733.96355747 0.0 -19.4616868017 1812.67751134 0.0 -19.4661636956 1572.07412139 0.0 -19.4726945434 1329.01932443 0.0 -19.4768031951 1084.92703449 0.0 -19.4806953023 767.698487403 0.0 -19.4863745598 602.50311053 0.0 -19.4904878838 517.894057728 0.0 -19.4948539143 468.279961054 0.0 -19.5001542127 446.411126688 0.0 -19.5035483596 455.667781546 0.0 -19.5080227021 510.054586059 0.0 -19.513484041 561.2351393 0.0 -19.5202371403 589.387582683 0.0 -19.5281669101 632.175593964 0.0 -19.5344097194 679.774333025 21.5098023457 -19.5394831894 691.30814319 0.0 -19.5449504787 707.174352374 2.3557613436 -19.5505619401 708.239678524 0.0 -19.5558782516 696.824851616 0.0 -19.5598334574 666.991961856 0.0 -19.5693540417 654.019470798 0.0 -19.5793540417 627.824436888 0.0 -19.5873995437 605.376607885 0.0 -19.5961498069 587.325564612 0.0 -19.6044078307 572.438969669 0.0 -19.6132405804 569.339627804 0.0 -19.6228305064 577.447702477 0.0 -19.6328305064 590.895340336 0.0 -19.6428305064 605.962775338 0.0 -19.6528305064 618.406983697 0.0 -19.6628305064 637.228030468 0.0 -19.6728305064 656.608592807 0.0 -19.6828305064 673.09915847 0.0 -19.6928305064 690.301970208 0.0 -19.698276708 714.299630385 0.0 -19.7057967638 727.496515749 0.0 -19.7133266581 741.928348444 0.0 -19.7229805741 762.836276555 0.0 -19.730871551 781.522921833 0.0 -19.7376445122 796.825711023 0.0 -19.7444181607 816.750948024 0.0 -19.7514069893 837.434226032 0.0 -19.7588257077 854.226257277 0.0 -19.7644909586 880.163548696 0.0 -19.7693206566 899.858735189 0.0 -19.7741387136 917.62148068 0.0 -19.7788612741 934.993126287 0.0 -19.7838360911 950.489183456 0.0 -19.7894549924 954.496004472 0.0 -19.7951343707 980.105207344 0.0 -19.8008710437 961.535983322 0.0 -19.8017600816 909.941578786 0.0 -19.8060058571 917.666872051 0.0 -19.8116341636 904.40318367 0.0 -19.8168495126 899.188381384 0.0 -19.8216303555 886.613287459 0.0 -19.8271222508 870.067465499 0.0 -19.8282254574 819.455288935 0.0 -19.8342589608 812.611115681 0.0 -19.8419968694 798.206417026 0.0 -19.8485988001 760.206753174 0.0 -19.8585194161 740.249272589 -0.280093327134 -19.8685194161 715.891882426 0.0592962279642 -19.875146789 682.667367913 0.0 -19.8771601193 656.366071904 0.0 -19.8780187044 598.014952611 0.0 -19.8787113998 555.785587976 0.0 -19.8832627624 553.38780619 0.0 -19.8893518672 562.321495202 -0.876001654372 -19.8951835023 553.537828926 -1.01664277354 -19.9013522198 533.870765403 0.0 -19.9082239617 532.030402792 0.0 -19.9090771121 578.442240895 0.0 -19.9119571493 582.764257523 0.0 -19.9156645724 584.275357193 0.0 -19.9251559243 573.437552176 0.0 -19.9351559243 569.324305463 0.0 -19.9416497997 689.263946441 0.0 -19.9436593105 835.974026256 0.0 -19.9466673632 802.204122307 0.0 -19.9494394547 743.250510506 0.0 -19.9527984963 691.249842343 0.0 -19.9582081382 630.522190458 0.0 -19.9653145569 656.302711716 0.0 -19.9667836753 626.581919412 0.0 -19.9727202859 626.981140547 0.0 -19.9755252375 622.643321713 0.0 -19.9791746796 542.476855184 0.0 -19.9891746796 531.650118996 0.0 -19.9896746796 617.304146743 0.0 -19.9968721379 574.445751338 0.0 -20.006158602 557.212777068 0.0 diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_mesh005.csv b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_mesh005.csv deleted file mode 100644 index f3c349c63025..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_mesh005.csv +++ /dev/null @@ -1,5603 +0,0 @@ -time (0.0,0.093) (0.0,0.299) -1e-06 0.0 0.0 -2e-06 0.0 0.0 -3e-06 0.0 0.0 -0.005003 -4.16618236481 0.0 -0.010003 21.1107481722 0.0 -0.015003 26.6256616313 0.0 -0.020003 30.8525744203 0.0 -0.025003 34.9170451591 0.0 -0.030003 40.4390384211 0.0 -0.036807068874 48.048595421 0.0 -0.0445775114661 56.6225598342 0.0 -0.0495775114661 60.7804746054 0.0 -0.0545775114661 63.8581905916 0.0 -0.0595775114661 64.3267830472 0.0 -0.0645775114661 63.650636665 0.0 -0.0695775114661 63.1440666027 0.0 -0.0745775114661 62.9832454355 0.0 -0.0795775114661 63.0163963045 0.0 -0.0845775114661 63.2502366167 0.0 -0.0895775114661 63.5430728906 0.0 -0.0945775114661 63.6303215231 0.0 -0.0995775114661 63.6813238692 0.0 -0.104577511466 63.7247790054 0.0 -0.109577511466 63.4896190727 0.0 -0.114577511466 63.3788030566 0.0 -0.119651670484 62.0983026863 0.0 -0.124651670484 62.334266762 0.0 -0.129651670484 63.0521569517 0.0 -0.134651670484 61.4839772287 0.0 -0.139651670484 61.1090790464 0.0 -0.144651670484 61.4239347392 0.0 -0.149651670484 62.4503159124 0.0 -0.154651670484 63.5695889301 0.0 -0.159651670484 63.9051969258 0.0 -0.164651670484 64.2075232768 0.0 -0.169651670484 64.7281727823 0.0 -0.174651670484 65.2678170512 0.0 -0.179651670484 65.7572181387 0.0 -0.184651670484 66.6895787449 0.0 -0.189651670484 68.1869271785 0.0 -0.194651670484 70.0256552358 0.0 -0.199651670484 71.83347209 0.0 -0.204651670484 73.4675418958 0.0 -0.209651670484 75.4042927653 0.0 -0.214651670484 76.2054087891 0.0 -0.219651670484 81.7631940182 0.0 -0.224651670484 85.0872714648 0.0 -0.229651670484 88.0636859381 0.0 -0.234651670484 90.8934349014 0.0 -0.239651670484 93.3968685761 0.0 -0.244651670484 96.0221990131 0.0 -0.249651670484 98.9703521051 0.0 -0.254651670484 102.082331491 0.0 -0.259651670484 105.390681688 0.0 -0.264651670484 109.390713094 0.0 -0.269651670484 113.183704886 0.0 -0.274651670484 116.940768567 0.0 -0.279651670484 119.315404257 0.0 -0.284651670484 121.576303916 0.0 -0.289651670484 125.595154851 0.0 -0.294651670484 128.063651793 0.0 -0.299651670484 130.511720113 0.0 -0.304651670484 132.53958681 0.0 -0.309651670484 135.072646529 0.0 -0.314651670484 137.32963976 0.0 -0.319651670484 139.056360729 0.0 -0.324651670484 140.447920969 0.0 -0.329651670484 141.632924016 0.0 -0.334651670484 142.853500444 0.0 -0.339651670484 143.64365341 0.0 -0.344651670484 145.206074749 0.0 -0.349651670484 146.588929932 0.0 -0.354651670484 147.913687163 0.0 -0.359651670484 148.964860296 0.0 -0.364651670484 149.416988901 0.0 -0.369651670484 149.986686912 0.0 -0.374651670484 150.744212284 0.0 -0.379651670484 152.014508903 0.0 -0.384651670484 153.56125384 0.0 -0.389651670484 155.678739746 0.0 -0.394651670484 157.80197974 0.0 -0.399651670484 160.29165957 0.0 -0.404651670484 162.923972259 0.0 -0.409651670484 165.557088266 0.0 -0.414651670484 167.996681351 0.0 -0.419651670484 170.70375692 0.0 -0.424651670484 174.70957138 0.0 -0.429651670484 177.579376886 0.0 -0.434651670484 180.59545241 0.0 -0.439651670484 183.35421011 0.0 -0.444651670484 186.015969833 0.0 -0.449651670484 188.968888743 0.0 -0.454651670484 191.646338515 0.0 -0.459651670484 194.795181032 0.0 -0.464651670484 197.692331333 0.0 -0.469651670484 200.750432994 0.0 -0.474651670484 203.571895842 0.0 -0.479651670484 207.204522808 0.0 -0.484651670484 210.655291775 0.0 -0.489651670484 215.401405191 0.0 -0.494651670484 219.058931925 0.0 -0.499651670484 222.530720914 0.0 -0.504651670484 225.817828244 0.0 -0.509651670484 229.490755477 0.0 -0.514651670484 232.494538394 0.0 -0.519651670484 235.396800241 0.0 -0.524651670484 238.39867768 0.0 -0.529651670484 241.308010836 0.0 -0.534651670484 240.942589772 0.0 -0.539651670484 247.583405296 0.0 -0.544651670484 250.16281755 0.0 -0.549651670484 252.115257137 0.0 -0.554651670484 247.391722052 0.0 -0.559651670484 256.18714516 0.0 -0.564651670484 258.389404628 0.0 -0.569651670484 260.354493524 0.0 -0.574651670484 261.886934975 0.0 -0.579651670484 263.885444583 0.0 -0.584651670484 266.802238202 0.0 -0.589651670484 268.899896201 0.0 -0.594651670484 270.986132311 0.0 -0.599651670484 273.352660451 0.0 -0.604651670484 268.577778823 0.0 -0.609651670484 277.916089868 0.0 -0.614651670484 280.512225671 0.0 -0.619651670484 280.949992653 0.0 -0.624651670484 275.436680079 0.0 -0.629651670484 285.726604686 0.0 -0.634651670484 288.004786997 0.0 -0.639651670484 290.154040069 0.0 -0.644651670484 292.05494182 0.0 -0.649651670484 293.496727661 0.0 -0.654651670484 295.062929866 0.0 -0.659651670484 297.237289019 0.0 -0.664651670484 300.05517585 0.0 -0.669651670484 302.697585804 0.0 -0.674651670484 306.010734859 0.0 -0.679651670484 308.377354627 0.0 -0.684651670484 310.223205919 0.0 -0.689651670484 312.36098924 0.0 -0.694651670484 314.692194474 0.0 -0.699651670484 316.685231878 0.0 -0.704651670484 318.568655322 0.0 -0.709651670484 320.462788858 0.0 -0.714651670484 320.265298337 0.0 -0.719651670484 324.486845648 0.0 -0.724651670484 324.629783894 0.0 -0.729651670484 324.661877006 0.0 -0.734651670484 325.060648344 0.0 -0.739651670484 321.142497575 0.0 -0.744651670484 326.518997656 0.0 -0.749651670484 327.120195702 0.0 -0.754651670484 327.352322259 0.0 -0.759651670484 327.968901565 0.0 -0.764651670484 327.949695367 0.0 -0.769651670484 328.236781888 0.0 -0.774651670484 323.89349117 0.0 -0.779651670484 328.856530199 0.0 -0.784651670484 329.332806206 0.0 -0.789651670484 329.296800684 0.0 -0.794651670484 328.920035123 0.0 -0.799651670484 322.590501679 0.0 -0.804651670484 328.138138373 0.0 -0.809651670484 327.902307294 0.0 -0.814651670484 327.054030911 0.0 -0.819651670484 324.573374624 0.0 -0.824651670484 324.19819769 0.0 -0.829651670484 317.46624891 0.0 -0.834651670484 323.480813511 0.0 -0.839651670484 323.171630621 0.0 -0.844651670484 321.36327256 0.0 -0.849651670484 318.192732828 0.0 -0.854651670484 315.685076982 0.0 -0.859651670484 313.813203774 0.0 -0.864651670484 314.043277845 0.0 -0.869651670484 305.280660205 0.0 -0.874651670484 312.070974734 0.0 -0.879651670484 311.268637437 0.0 -0.884651670484 309.270391945 0.0 -0.889651670484 306.611970004 0.0 -0.894651670484 299.180675774 0.0 -0.899651670484 300.328123456 0.0 -0.904651670484 299.860240838 0.0 -0.909651670484 295.252716986 0.0 -0.914651670484 297.139602661 0.0 -0.919651670484 296.498270329 0.0 -0.924651670484 295.865837229 0.0 -0.929651670484 295.030036414 0.0 -0.934651670484 294.476871176 0.0 -0.939651670484 293.535960785 0.0 -0.944651670484 290.402164528 0.0 -0.949820684135 291.705795551 0.0 -0.954820684135 290.661322088 0.0 -0.959820684135 285.398297398 0.0 -0.964820684135 286.520377411 0.0 -0.969820684135 284.112620587 0.0 -0.974820684135 281.316122791 0.0 -0.979820684135 273.500461827 0.0 -0.984820684135 274.460429315 0.0 -0.989820684135 271.387449944 0.0 -0.994820684135 267.947352858 0.0 -0.999820684135 253.209696837 0.0 -1.00482068413 258.275394927 0.0 -1.00982068413 254.331291529 0.0 -1.01482068413 250.126530899 0.0 -1.01982068413 240.799459217 0.0 -1.02482068413 240.429230366 0.0 -1.02982068413 236.686965598 0.0 -1.03482068413 226.99359996 0.0 -1.03982068413 226.985977759 0.0 -1.04482068413 223.739091105 0.0 -1.04982068413 220.651966271 0.0 -1.05482068413 211.471412514 0.0 -1.05982068413 211.357671444 0.0 -1.06482068413 208.362375614 0.0 -1.06982068413 199.820669848 0.0 -1.07482068413 200.206445252 0.0 -1.07982068413 198.845357148 0.0 -1.08482068413 189.31814501 0.0 -1.08982068413 189.313832454 0.0 -1.09482068413 185.960028742 0.0 -1.09982068413 176.524038256 0.0 -1.10482068413 177.089594224 0.0 -1.10982068413 170.777403523 0.0 -1.11482068413 159.873785914 0.0 -1.11982068413 158.149748808 0.0 -1.12482068413 151.736789882 0.0 -1.12982068413 147.875110251 0.0 -1.13482068413 145.026508228 0.0 -1.13982068413 142.833696807 0.0 -1.14482068413 139.275723309 0.0 -1.14982068413 136.545972779 0.0 -1.15482068413 123.916284433 0.0 -1.15982068413 116.816176297 0.0 -1.16482068413 110.190984439 0.0 -1.16982068413 103.027957756 0.0 -1.17482068413 108.507507453 0.0 -1.17982068413 110.89937986 0.0 -1.18482068413 112.828244054 0.0 -1.18982068413 113.47999426 0.0 -1.19482068413 101.313910507 0.0 -1.19982068413 104.742442311 0.0 -1.20482068413 108.609399467 0.0 -1.20982068413 103.9145089 0.0 -1.21482068413 98.5670052881 0.0 -1.21982068413 90.2696568285 0.0 -1.22482068413 78.970716796 0.0 -1.22982068413 74.0662084445 0.0 -1.23482068413 71.1804645948 0.0 -1.23982068413 69.2822521459 0.0 -1.24482068413 67.5584833424 0.0 -1.24982068413 65.9482128615 0.0 -1.25482068413 63.8971542939 0.0 -1.25982068413 61.7883979861 0.0 -1.26482068413 59.177912981 0.0 -1.26982068413 55.7154183381 0.0 -1.27482068413 51.3471079447 0.0 -1.27982068413 46.2860674803 0.0 -1.28482068413 40.1138805472 0.0 -1.28982068413 33.1077856435 0.0 -1.29482068413 26.3232582541 0.0 -1.29982068413 17.6255592819 0.0 -1.30482068413 11.0683419548 0.0 -1.30982068413 5.06606092325 0.0 -1.31482068413 0.457916708541 0.0 -1.31982068413 -12.977088118 0.0 -1.32482068413 -25.2690795185 0.0 -1.32982068413 -35.9179711143 0.0 -1.33482068413 -46.4510108197 0.0 -1.33982068413 -55.6430501838 0.0 -1.34482068413 -62.9004512024 0.0 -1.34982068413 -66.0629479319 0.0 -1.35482068413 -64.1891553406 0.0 -1.35982068413 -45.6098988449 0.0 -1.36482068413 -33.7824900567 0.0 -1.36982068413 -21.1275086262 0.0 -1.37482068413 -20.9194172734 0.0 -1.37982068413 -20.9194172734 0.0 -1.38482068413 -20.9194172734 0.0 -1.38982068413 -20.9194172734 0.0 -1.39482068413 -20.9194172734 0.0 -1.39982068413 -20.9194172734 0.0 -1.40482068413 -20.9194172734 0.0 -1.40982068413 -20.9194172734 0.0 -1.41482068413 -20.9194172734 0.0 -1.41982068413 -20.9194172734 0.0 -1.42482068413 -20.9194172734 0.0 -1.42982068413 -20.9194172734 0.0 -1.43482068413 -20.9194172734 0.0 -1.43982068413 -20.9194172734 0.0 -1.44482068413 -20.9194172734 0.0 -1.44982068413 -20.9194172734 0.0 -1.45482068413 -20.9194172734 0.0 -1.45982068413 -20.9194172734 0.0 -1.46482068413 -20.9194172734 0.0 -1.46982068413 -20.9194172734 0.0 -1.47482068413 -20.9194172734 0.0 -1.47982068413 -20.9194172734 0.0 -1.48482068413 -20.9194172734 0.0 -1.48982068413 -20.9194172734 0.0 -1.49482068413 -20.9194172734 0.0 -1.49982068413 -20.9194172734 0.0 -1.50482068413 -20.9194172734 0.0 -1.50982068413 -20.9194172734 0.0 -1.51482068413 -20.9194172734 0.0 -1.51982068413 -20.9194172734 0.0 -1.52482068413 -20.9194172734 0.0 -1.52982068413 -20.9194172734 0.0 -1.53482068413 -20.9194172734 0.0 -1.53982068413 -20.9194172734 0.0 -1.54482068413 -20.9194172734 0.0 -1.54982068413 -20.9194172734 0.0 -1.55482068413 -20.9194172734 0.0 -1.55982068413 -20.9194172734 0.0 -1.56482068413 -20.9194172734 0.0 -1.56982068413 -20.9194172734 0.0 -1.57482068413 -20.9194172734 0.0 -1.57982068413 -20.9194172734 0.0 -1.58482068413 -20.9194172734 0.0 -1.58982068413 -20.9194172734 0.0 -1.59482068413 -20.9194172734 0.0 -1.59982068413 -20.9194172734 0.0 -1.60482068413 -20.9194172734 0.0 -1.60982068413 -20.9194172734 0.0 -1.61482068413 -20.9194172734 0.0 -1.61982068413 -20.9194172734 0.0 -1.62482068413 -20.9194172734 0.0 -1.62982068413 -20.9194172734 0.0 -1.63482068413 -20.9194172734 0.0 -1.63982068413 -20.9194172734 0.0 -1.64482068413 -20.9194172734 0.0 -1.64982068413 -20.9194172734 0.0 -1.65482068413 -20.9194172734 0.0 -1.65982068413 -20.9194172734 0.0 -1.66482068413 -20.9194172734 0.0 -1.66982068413 -20.9194172734 0.0 -1.67482068413 -20.9194172734 0.0 -1.67982068413 -20.9194172734 0.0 -1.68482068413 -20.9194172734 0.0 -1.68982068413 -20.9194172734 0.0 -1.69482068413 -20.9194172734 0.0 -1.69982068413 -20.9194172734 0.0 -1.70482068413 -20.9194172734 0.0 -1.70982068413 -20.9194172734 0.0 -1.71482068413 -20.9194172734 0.0 -1.71982068413 -20.9194172734 0.0 -1.72482068413 -20.9194172734 0.0 -1.72982068413 -20.9194172734 0.0 -1.73482068413 -20.9194172734 0.0 -1.73982068413 -20.9194172734 0.0 -1.74482068413 -20.9194172734 0.0 -1.74982068413 -20.9194172734 0.0 -1.75482068413 -20.9194172734 0.0 -1.75982068413 -20.9194172734 0.0 -1.76482068413 -20.9194172734 0.0 -1.76982068413 -20.9194172734 0.0 -1.77482068413 -20.9194172734 0.0 -1.77982068413 -20.9194172734 0.0 -1.78482068413 -20.9194172734 0.0 -1.78982068413 -20.9194172734 0.0 -1.79482068413 -20.9194172734 0.0 -1.79982068413 -20.9194172734 0.0 -1.80482068413 -20.9194172734 0.0 -1.80982068413 -20.9194172734 0.0 -1.81482068413 -20.9194172734 0.0 -1.81982068413 -20.9194172734 0.0 -1.82482068413 -20.9194172734 0.0 -1.82982068413 -20.9194172734 0.0 -1.83482068413 -20.9194172734 0.0 -1.83982068413 -20.9194172734 0.0 -1.84482068413 -20.9194172734 0.0 -1.84982068413 -20.9194172734 0.0 -1.85482068413 -20.9194172734 0.0 -1.85982068413 -20.9194172734 0.0 -1.86482068413 -20.9194172734 0.0 -1.86982068413 -20.9194172734 0.0 -1.87482068413 -20.9194172734 0.0 -1.87982068413 -20.9194172734 0.0 -1.88482068413 -20.9194172734 0.0 -1.88982068413 -20.9194172734 0.0 -1.89482068413 -20.9194172734 0.0 -1.89982068413 -20.9194172734 0.0 -1.90482068413 -20.9194172734 0.0 -1.90982068413 -20.9194172734 0.0 -1.91482068413 -20.9194172734 0.0 -1.91982068413 -20.9194172734 0.0 -1.92482068413 -20.9194172734 0.0 -1.92982068413 -20.9194172734 0.0 -1.93482068413 -20.9194172734 0.0 -1.93982068413 -20.9194172734 0.0 -1.94482068413 -20.9194172734 0.0 -1.94982068413 -20.9194172734 0.0 -1.95482068413 -20.9194172734 0.0 -1.95982068413 -20.9194172734 0.0 -1.96482068413 -20.9194172734 0.0 -1.96982068413 -20.9194172734 0.0 -1.97482068413 -20.9194172734 0.0 -1.97982068413 -20.9194172734 0.0 -1.98482068413 -20.9194172734 0.0 -1.98982068413 -20.9194172734 0.0 -1.99482068413 -20.9194172734 0.0 -1.99982068413 -20.9194172734 0.0 -2.00482068413 -20.9194172734 0.0 -2.00982068413 -20.9194172734 0.0 -2.01482068413 -20.9194172734 0.0 -2.01982068413 -20.9194172734 0.0 -2.02482068413 -20.9194172734 0.0 -2.02982068413 -20.9194172734 0.0 -2.03482068413 -20.9194172734 0.0 -2.03982068413 -20.9194172734 0.0 -2.04482068413 -20.9194172734 0.0 -2.04982068413 -20.9194172734 0.0 -2.05482068413 -20.9194172734 0.0 -2.05982068413 -20.9194172734 0.0 -2.06482068413 -20.9194172734 0.0 -2.06982068413 -20.9194172734 0.0 -2.07482068413 -20.9194172734 0.0 -2.07982068413 -20.9194172734 0.0 -2.08482068413 -20.9194172734 0.0 -2.08982068413 -20.9194172734 0.0 -2.09482068413 -20.9194172734 0.0 -2.09982068413 -20.9194172734 0.0 -2.10482068413 -20.9194172734 0.0 -2.10982068413 -20.9194172734 0.0 -2.11482068413 -20.9194172734 0.0 -2.11982068413 -20.9194172734 0.0 -2.12482068413 -20.9194172734 0.0 -2.12982068413 -20.9194172734 0.0 -2.13482068413 -20.9194172734 0.0 -2.13982068413 -20.9194172734 0.0 -2.14482068413 -20.9194172734 0.0 -2.14982068413 -20.9194172734 0.0 -2.15482068413 -20.9194172734 0.0 -2.15982068413 -20.9194172734 0.0 -2.16482068413 -20.9194172734 0.0 -2.16982068413 -20.9194172734 0.0 -2.17482068413 -20.9194172734 0.0 -2.17982068413 -20.9194172734 0.0 -2.18482068413 -20.9194172734 0.0 -2.18982068413 -20.9194172734 0.0 -2.19482068413 -20.9194172734 0.0 -2.19982068413 -20.9194172734 0.0 -2.20482068413 -20.9194172734 0.0 -2.20982068413 -20.9194172734 0.0 -2.21482068413 -20.9194172734 0.0 -2.21982068413 -20.9194172734 0.0 -2.22482068413 -20.9194172734 0.0 -2.22982068413 -20.9194172734 0.0 -2.23482068413 -20.9194172734 0.0 -2.23982068413 -20.9194172734 0.0 -2.24482068413 -20.9194172734 0.0 -2.24982068413 -20.9194172734 0.0 -2.25482068413 -20.9194172734 0.0 -2.25982068413 -20.9194172734 0.0 -2.26482068413 -20.9194172734 0.0 -2.26982068413 -20.9194172734 0.0 -2.27482068413 -20.9194172734 0.0 -2.27982068413 -20.9194172734 0.0 -2.28482068413 -20.9194172734 0.0 -2.28982068413 -20.9194172734 0.0 -2.29482068413 -20.9194172734 0.0 -2.29982068413 -20.9194172734 0.0 -2.30482068413 -20.9194172734 0.0 -2.30982068413 -20.9194172734 0.0 -2.31482068413 -20.9194172734 0.0 -2.31982068413 -20.9194172734 0.0 -2.32482068413 -20.9194172734 0.0 -2.32982068413 -20.9194172734 0.0 -2.33482068413 -20.9194172734 0.0 -2.33982068413 -20.9194172734 0.0 -2.34482068413 -20.9194172734 0.0 -2.34982068413 -20.9194172734 0.0 -2.35482068413 -20.9194172734 0.0 -2.35982068413 -20.9194172734 0.0 -2.36482068413 -20.9194172734 0.0 -2.36982068413 -35.1101569922 0.0 -2.37482068413 -11.1440626842 0.0 -2.37982068413 135.619900964 0.0 -2.38482068413 285.002521652 0.0 -2.38982068413 436.726387083 0.0 -2.39482068413 604.945183886 0.0 -2.39982068413 820.15992783 0.0 -2.40482068413 993.696469878 0.0 -2.40982068413 1189.62810204 0.0 -2.41482068413 1364.50285447 0.0 -2.41982068413 1410.51036918 0.0 -2.42482068413 1374.01098869 0.0 -2.42982068413 1265.01030222 0.0 -2.43482068413 1130.05143764 0.0 -2.43982068413 1003.3537702 0.0 -2.44482068413 890.713362619 0.0 -2.44982068413 787.716840168 0.0 -2.45482068413 693.668296668 0.0 -2.45982068413 621.149380957 0.0 -2.46482068413 566.799356562 0.0 -2.46982068413 527.533759355 0.0 -2.47482068413 498.716775515 0.0 -2.47982068413 484.622624595 10.8562371475 -2.48482068413 482.970343068 3.62150439406 -2.48982068413 489.986780065 3.62150439406 -2.49482068413 505.793682856 3.62150439406 -2.49982068413 523.718940047 6.02288468643 -2.50482068413 544.755885396 3.33588642873 -2.50982068413 565.84903547 3.63657747298 -2.51482068413 588.418139134 3.79695689082 -2.51982068413 611.506850731 3.79695689082 -2.52482068413 631.278052713 3.79695689082 -2.52982068413 649.987661435 3.79695689082 -2.53482068413 664.438999927 3.79695689082 -2.53982068413 673.281112989 3.79695689082 -2.54482068413 679.912722663 3.79695689082 -2.54982068413 683.433447114 3.79695689082 -2.55482068413 684.816861743 8.93711977516 -2.55982068413 685.286398436 8.93711977516 -2.56482068413 683.256410242 8.93711977516 -2.56982068413 680.979859309 8.93711977516 -2.57482068413 678.776530441 8.93711977516 -2.57982068413 675.95878484 8.93711977516 -2.58482068413 673.454898919 8.93711977516 -2.58982068413 674.598224805 8.93711977516 -2.59482068413 676.858443612 8.93711977516 -2.59982068413 680.44142153 8.93711977516 -2.60482068413 684.822774977 8.93711977516 -2.60982068413 690.608318122 8.93711977516 -2.61482068413 699.379437256 8.93711977516 -2.61982068413 705.434860995 8.93711977516 -2.62482068413 713.903960189 8.93711977516 -2.62982068413 723.560416484 8.93711977516 -2.63482068413 735.27699896 8.93711977516 -2.63982068413 749.479928276 8.93711977516 -2.64482068413 765.246294092 8.93711977516 -2.64982068413 781.154333385 8.93711977516 -2.65482068413 797.971382076 8.93711977516 -2.65982068413 815.505604153 8.93711977516 -2.66482068413 835.856624281 1.16612142477 -2.66982068413 849.955542892 1.16612142477 -2.67482068413 867.145579244 0.838248116106 -2.67982068413 886.146104833 0.838248116106 -2.68482068413 900.182739635 0.838248116106 -2.68982068413 912.498358918 0.838248116106 -2.69482068413 922.341054439 0.838248116106 -2.69982068413 927.479028035 0.838248116106 -2.70482068413 927.411345129 0.838248116106 -2.70982068413 924.916262294 0.838248116106 -2.71482068413 921.430941126 0.838248116106 -2.71982068413 918.296278245 0.838248116106 -2.72482068413 913.078510493 0.838248116106 -2.72982068413 926.869861632 0.838248116106 -2.73482068413 913.542049918 0.838248116106 -2.73982068413 898.924374191 0.838248116106 -2.74482068413 896.55525593 -0.656545397406 -2.74982068413 870.650466695 -0.812601342163 -2.75482068413 845.716815545 -0.812601342163 -2.75982068413 808.680529901 -0.812601342163 -2.76482068413 777.60508001 -0.812601342163 -2.76982068413 751.215476964 -0.812601342163 -2.77482068413 721.408126149 -0.812601342163 -2.77982068413 694.251156417 -0.812601342163 -2.78482068413 647.673844686 -0.812601342163 -2.78982068413 584.126745796 -0.812601342163 -2.79482068413 530.216566073 -0.812601342163 -2.79982068413 479.292675481 -0.812601342163 -2.80482068413 434.21597592 -0.812601342163 -2.80982068413 395.801184388 -0.812601342163 -2.81482068413 363.218226796 -0.812601342163 -2.81982068413 385.068115076 -0.812601342163 -2.82482068413 378.432523482 -0.812601342163 -2.82982068413 337.864093255 -0.812601342163 -2.83482068413 296.335184505 -0.812601342163 -2.83982068413 443.246693857 -0.812601342163 -2.84482068413 340.136090177 -0.812601342163 -2.84982068413 346.902587382 -0.812601342163 -2.85482068413 315.447863043 -0.812601342163 -2.85982068413 284.129787803 -0.812601342163 -2.86482068413 284.125978014 -0.812601342163 -2.86982068413 270.436142144 -0.812601342163 -2.87482068413 261.780401058 -0.812601342163 -2.87982068413 230.833138904 -0.812601342163 -2.88482068413 227.44463052 -0.812601342163 -2.88982068413 224.430632202 -0.812601342163 -2.89482068413 244.171545882 -0.812601342163 -2.89982068413 246.210546956 -0.812601342163 -2.90482068413 237.197116222 -0.812601342163 -2.90982068413 228.827233429 -0.812601342163 -2.91482068413 237.137625829 -0.812601342163 -2.91982068413 240.414514084 -0.812601342163 -2.92482068413 253.192531682 -0.812601342163 -2.92982068413 318.555539327 -0.812601342163 -2.93482068413 329.700324068 -0.812601342163 -2.93982068413 365.049591888 -0.812601342163 -2.94482068413 320.662733929 -0.812601342163 -2.94982068413 289.447850664 -0.812601342163 -2.95482068413 299.009495979 -0.812601342163 -2.95982068413 299.654589916 -0.812601342163 -2.96482068413 311.856817526 -0.812601342163 -2.96982068413 284.984983809 -0.812601342163 -2.97482068413 280.291440876 -0.812601342163 -2.97982068413 295.413621087 -0.812601342163 -2.98482068413 307.347318447 -0.812601342163 -2.98982068413 330.986160112 -0.812601342163 -2.99482068413 325.854752477 -0.812601342163 -2.99982068413 326.140226597 -0.812601342163 -3.00482068413 321.787857517 -0.812601342163 -3.00982068413 320.815083376 -0.812601342163 -3.01482068413 326.278546482 -0.812601342163 -3.01982068413 314.731530605 -0.812601342163 -3.02482068413 303.910646835 -0.812601342163 -3.02982068413 279.160318778 -0.812601342163 -3.03482068413 270.135285271 -0.812601342163 -3.03982068413 252.993805341 -0.812601342163 -3.04482068413 237.421411403 -0.812601342163 -3.04982068413 226.046128693 -0.812601342163 -3.05482068413 229.356860431 -0.812601342163 -3.05982068413 221.867218565 -0.812601342163 -3.06482068413 211.913916808 -0.812601342163 -3.06982068413 217.221233493 -0.812601342163 -3.07482068413 214.479913857 -0.812601342163 -3.07982068413 208.46450957 -0.812601342163 -3.08482068413 196.295171882 -0.812601342163 -3.08982068413 208.675152354 -0.812601342163 -3.09482068413 192.220776253 -0.812601342163 -3.09982068413 192.220776253 -0.812601342163 -3.10482068413 200.869670942 -0.812601342163 -3.10982068413 195.60706197 -0.812601342163 -3.11482068413 191.771044522 -0.812601342163 -3.11982068413 184.977520723 -0.812601342163 -3.12482068413 182.057758086 -0.812601342163 -3.12982068413 182.808640316 -0.812601342163 -3.13482068413 180.992334134 -0.812601342163 -3.13982068413 177.593216618 -0.812601342163 -3.14482068413 176.351399146 -0.812601342163 -3.14982068413 151.804009871 -0.812601342163 -3.15482068413 161.538808436 -0.812601342163 -3.15982068413 157.99105963 -0.812601342163 -3.16482068413 155.975537782 -0.812601342163 -3.16982068413 146.594867124 -0.812601342163 -3.17482068413 137.120678093 -0.812601342163 -3.17982068413 126.587718994 -0.812601342163 -3.18482068413 116.766078426 -0.812601342163 -3.18982068413 105.216601666 -0.812601342163 -3.19482068413 81.6293644361 -0.812601342163 -3.19982068413 78.1129294284 -0.812601342163 -3.20482068413 68.9826847429 -0.812601342163 -3.20982068413 55.9142135965 -0.812601342163 -3.21482068413 51.2936344537 -0.812601342163 -3.21982068413 48.7902678687 -0.812601342163 -3.22482068413 14.2974834715 -0.812601342163 -3.22982068413 15.5545687858 -0.812601342163 -3.23482068413 27.7083171726 -0.812601342163 -3.23982068413 -4.00526983738 -0.812601342163 -3.24482068413 -26.3203998047 -0.812601342163 -3.24982068413 -32.9500225011 -0.812601342163 -3.25482068413 -13.3142514444 -0.812601342163 -3.25982068413 -10.6069939352 -0.812601342163 -3.26482068413 -12.0672687435 -0.812601342163 -3.26982068413 -11.1850141536 -0.812601342163 -3.27482068413 -15.143750719 -0.812601342163 -3.27982068413 -25.3598589823 -0.812601342163 -3.28482068413 -29.5046148528 -0.812601342163 -3.28982068413 -41.161633647 -0.812601342163 -3.29482068413 -51.1263830793 -0.812601342163 -3.29982068413 -51.1263830793 -0.812601342163 -3.30482068413 -51.1263830793 -0.812601342163 -3.30982068413 -51.1263830793 -0.812601342163 -3.31482068413 -51.1263830793 -0.812601342163 -3.31982068413 -51.1263830793 -0.812601342163 -3.32482068413 -51.1263830793 -0.812601342163 -3.32982068413 -51.1263830793 -0.812601342163 -3.33482068413 -51.1263830793 -0.812601342163 -3.33982068413 -51.1263830793 -0.812601342163 -3.34482068413 -51.1263830793 -0.812601342163 -3.34982068413 -51.1263830793 -0.812601342163 -3.35482068413 -51.1263830793 -0.812601342163 -3.35982068413 -51.1263830793 -0.812601342163 -3.36482068413 -51.1263830793 -0.812601342163 -3.36982068413 -51.1263830793 -0.812601342163 -3.37482068413 -51.1263830793 -0.812601342163 -3.37982068413 -51.1263830793 -0.812601342163 -3.38482068413 -51.1263830793 -0.812601342163 -3.38982068413 -51.1263830793 -0.812601342163 -3.39482068413 -51.1263830793 -0.812601342163 -3.39982068413 -51.1263830793 -0.812601342163 -3.40482068413 -51.1263830793 -0.812601342163 -3.40982068413 -51.1263830793 -0.812601342163 -3.41482068413 -51.1263830793 -0.812601342163 -3.41982068413 -51.1263830793 -0.812601342163 -3.42482068413 -51.1263830793 -0.812601342163 -3.42982068413 -51.1263830793 -0.812601342163 -3.43482068413 -51.1263830793 -0.812601342163 -3.43982068413 -51.1263830793 -0.812601342163 -3.44482068413 -51.1263830793 -0.812601342163 -3.44982068413 -51.1263830793 -0.812601342163 -3.45482068413 -51.1263830793 -0.812601342163 -3.45982068413 -51.1263830793 -0.812601342163 -3.46482068413 -51.1263830793 -0.812601342163 -3.46982068413 -51.1263830793 -0.812601342163 -3.47482068413 -51.1263830793 -0.812601342163 -3.47982068413 -51.1263830793 -0.812601342163 -3.48482068413 -51.1263830793 -0.812601342163 -3.48982068413 -51.1263830793 -0.812601342163 -3.49482068413 -51.1263830793 -0.812601342163 -3.49982068413 -51.1263830793 -0.812601342163 -3.50482068413 -51.1263830793 -0.812601342163 -3.50982068413 -51.1263830793 -0.812601342163 -3.51482068413 -51.1263830793 -0.812601342163 -3.51982068413 -51.1263830793 -0.812601342163 -3.52482068413 -51.1263830793 -0.812601342163 -3.52982068413 -51.1263830793 -0.812601342163 -3.53482068413 -51.1263830793 -0.812601342163 -3.53982068413 -51.1263830793 -0.812601342163 -3.54482068413 -51.1263830793 -0.812601342163 -3.54982068413 -51.1263830793 -0.812601342163 -3.55482068413 -51.1263830793 -0.812601342163 -3.55982068413 -51.1263830793 -0.812601342163 -3.56482068413 -51.1263830793 -0.812601342163 -3.56982068413 -51.1263830793 -0.812601342163 -3.57482068413 -51.1263830793 -0.812601342163 -3.57982068413 -51.1263830793 -0.812601342163 -3.58482068413 -51.1263830793 -0.812601342163 -3.58982068413 -51.1263830793 -0.812601342163 -3.59482068413 -51.1263830793 -0.812601342163 -3.59982068413 -51.1263830793 -0.812601342163 -3.60482068413 -51.1263830793 -0.812601342163 -3.60982068413 -51.1263830793 -0.812601342163 -3.61482068413 -51.1263830793 -0.812601342163 -3.61982068413 -51.1263830793 -0.812601342163 -3.62482068413 -51.1263830793 -0.812601342163 -3.62982068413 -51.1263830793 -0.812601342163 -3.63482068413 -51.1263830793 -0.812601342163 -3.63982068413 -51.1263830793 -0.812601342163 -3.64482068413 -51.1263830793 -0.812601342163 -3.64982068413 -51.1263830793 -0.812601342163 -3.65482068413 -51.1263830793 -0.812601342163 -3.65982068413 -51.1263830793 -0.812601342163 -3.66482068413 -51.1263830793 -0.812601342163 -3.66982068413 -51.1263830793 -0.812601342163 -3.67482068413 -51.1263830793 -0.812601342163 -3.67982068413 -51.1263830793 -0.812601342163 -3.68482068413 -51.1263830793 -0.812601342163 -3.68982068413 -51.1263830793 -0.812601342163 -3.69482068413 -51.1263830793 -0.812601342163 -3.69982068413 -51.1263830793 -0.812601342163 -3.70482068413 -51.1263830793 -0.812601342163 -3.70982068413 -51.1263830793 -0.812601342163 -3.71482068413 -51.1263830793 -0.812601342163 -3.71982068413 -51.1263830793 -0.812601342163 -3.72482068413 -51.1263830793 -0.812601342163 -3.72982068413 -51.1263830793 -0.812601342163 -3.73482068413 -51.1263830793 -0.812601342163 -3.73982068413 -51.1263830793 -0.812601342163 -3.74482068413 -51.1263830793 -0.812601342163 -3.74982068413 -51.1263830793 -0.812601342163 -3.75482068413 -51.1263830793 -0.812601342163 -3.75982068413 -51.1263830793 -0.812601342163 -3.76482068413 -51.1263830793 -0.812601342163 -3.76982068413 -51.1263830793 -0.812601342163 -3.77482068413 -51.1263830793 -0.812601342163 -3.77982068413 -51.1263830793 -0.812601342163 -3.78482068413 -51.1263830793 -0.812601342163 -3.78982068413 -51.1263830793 -0.812601342163 -3.79482068413 -51.1263830793 -0.812601342163 -3.79982068413 -51.1263830793 -0.812601342163 -3.80482068413 -51.1263830793 -0.812601342163 -3.80982068413 -51.1263830793 -0.812601342163 -3.81482068413 -51.1263830793 -0.812601342163 -3.81982068413 -51.1263830793 -0.812601342163 -3.82482068413 -51.1263830793 -0.812601342163 -3.82982068413 -51.1263830793 -0.812601342163 -3.83482068413 -51.1263830793 -0.812601342163 -3.83982068413 -51.1263830793 -0.812601342163 -3.84482068413 -51.1263830793 -0.812601342163 -3.84982068413 -51.1263830793 -0.812601342163 -3.85482068413 -51.1263830793 -0.812601342163 -3.85982068413 -51.1263830793 -0.812601342163 -3.86482068413 -51.1263830793 -0.812601342163 -3.86982068413 -51.1263830793 -0.812601342163 -3.87482068413 -51.1263830793 -0.812601342163 -3.87982068413 -51.1263830793 -0.812601342163 -3.88482068413 -51.1263830793 -0.812601342163 -3.88982068413 -51.1263830793 -0.812601342163 -3.89482068413 -51.1263830793 -0.812601342163 -3.89982068413 -51.1263830793 -0.812601342163 -3.90482068413 -51.1263830793 -0.812601342163 -3.90982068413 -51.1263830793 -0.812601342163 -3.91482068413 -51.1263830793 -0.812601342163 -3.91982068413 -51.1263830793 -0.812601342163 -3.92482068413 -51.1263830793 -0.812601342163 -3.92982068413 -51.1263830793 -0.812601342163 -3.93482068413 -51.1263830793 -0.812601342163 -3.93982068413 -51.1263830793 -0.812601342163 -3.94482068413 -51.1263830793 -0.812601342163 -3.94982068413 -51.1263830793 -0.812601342163 -3.95482068413 -51.1263830793 -0.812601342163 -3.95982068413 -51.1263830793 -0.812601342163 -3.96482068413 -51.1263830793 -0.812601342163 -3.96982068413 -51.1263830793 -0.812601342163 -3.97482068413 -51.1263830793 -0.812601342163 -3.97982068413 -51.1263830793 -0.812601342163 -3.98482068413 -51.1263830793 -0.812601342163 -3.98982068413 -51.1263830793 -0.812601342163 -3.99482068413 -51.1263830793 -0.812601342163 -3.99982068413 -51.1263830793 -0.812601342163 -4.00482068413 -51.1263830793 -0.812601342163 -4.00982068413 -51.1263830793 -0.812601342163 -4.01482068413 -51.1263830793 -0.812601342163 -4.01982068413 -51.1263830793 -0.812601342163 -4.02482068413 -51.1263830793 -0.812601342163 -4.02982068413 -51.1263830793 -0.812601342163 -4.03482068413 -51.1263830793 -0.812601342163 -4.03982068413 -51.1263830793 -0.812601342163 -4.04482068413 -51.1263830793 -0.812601342163 -4.04982068413 -51.1263830793 -0.812601342163 -4.05482068413 -51.1263830793 -0.812601342163 -4.05982068413 -51.1263830793 -0.812601342163 -4.06482068413 -51.1263830793 -0.812601342163 -4.06982068413 -51.1263830793 -0.812601342163 -4.07482068413 -51.1263830793 -0.812601342163 -4.07982068413 -51.1263830793 -0.812601342163 -4.08482068413 -51.1263830793 -0.812601342163 -4.08982068413 -51.1263830793 -0.812601342163 -4.09482068413 -51.1263830793 -0.812601342163 -4.09982068413 -51.1263830793 -0.812601342163 -4.10482068413 -51.1263830793 -0.812601342163 -4.10982068413 -51.1263830793 -0.812601342163 -4.11482068413 -51.1263830793 -0.812601342163 -4.11982068413 -51.1263830793 -0.812601342163 -4.12482068413 -51.1263830793 -0.812601342163 -4.12982068413 -51.1263830793 -0.812601342163 -4.13482068413 -51.1263830793 -0.812601342163 -4.13982068413 -51.1263830793 -0.812601342163 -4.14482068413 -51.1263830793 -0.812601342163 -4.14982068413 -51.1263830793 -0.812601342163 -4.15482068413 -51.1263830793 -0.812601342163 -4.15982068413 -51.1263830793 -0.812601342163 -4.16482068413 -51.1263830793 -0.812601342163 -4.16982068413 -51.1263830793 -0.812601342163 -4.17482068413 -51.1263830793 -0.812601342163 -4.17982068413 -51.1263830793 -0.812601342163 -4.18482068413 -51.1263830793 -0.812601342163 -4.18982068413 -51.1263830793 -0.812601342163 -4.19482068413 -51.1263830793 -0.812601342163 -4.19982068413 -51.1263830793 -0.812601342163 -4.20482068413 -51.1263830793 -0.812601342163 -4.20982068413 -51.1263830793 -0.812601342163 -4.21482068413 -51.1263830793 -0.812601342163 -4.21982068413 -51.1263830793 -0.812601342163 -4.22482068413 -51.1263830793 -0.812601342163 -4.22982068413 -51.1263830793 -0.812601342163 -4.23482068413 -51.1263830793 -0.812601342163 -4.23982068413 -51.1263830793 -0.812601342163 -4.24482068413 -51.1263830793 -0.812601342163 -4.24982068413 1445.20336292 -0.812601342163 -4.25482068413 1152.84499848 -0.812601342163 -4.25982068413 651.237870482 -0.812601342163 -4.26482068413 1047.50453085 -0.812601342163 -4.26982068413 1041.98236968 -0.812601342163 -4.27482068413 1146.33432175 -0.812601342163 -4.27982068413 1027.690092 -0.812601342163 -4.28482068413 1156.84302184 -0.812601342163 -4.28982068413 1170.3296138 -0.812601342163 -4.29482068413 1136.81132664 -0.812601342163 -4.29982068413 989.362238357 -0.812601342163 -4.30482068413 905.125382027 -0.812601342163 -4.30982068413 841.256393338 -0.812601342163 -4.31482068413 757.437361609 -0.812601342163 -4.31982068413 672.575605189 -0.812601342163 -4.32482068413 602.349260849 -0.812601342163 -4.32982068413 555.25403111 -0.812601342163 -4.33482068413 523.928748769 -0.812601342163 -4.33982068413 499.432140027 -0.812601342163 -4.34482068413 476.02565893 -0.812601342163 -4.34982068413 476.310918203 -0.812601342163 -4.35482068413 485.621713116 -0.812601342163 -4.35982068413 503.768251543 -0.812601342163 -4.36482068413 517.775822936 -0.812601342163 -4.36982068413 538.284456358 -0.812601342163 -4.37482068413 562.581424807 -0.812601342163 -4.37982068413 579.969263855 5.11408436183 -4.38482068413 597.355188756 5.11408436183 -4.38982068413 611.572741116 5.11408436183 -4.39482068413 620.911529327 5.11408436183 -4.39982068413 628.205441693 5.11408436183 -4.40482068413 630.996699616 5.11408436183 -4.40982068413 626.699897164 5.11408436183 -4.41482068413 622.43375913 5.11408436183 -4.41982068413 615.128411248 5.11408436183 -4.42482068413 608.528611396 5.11408436183 -4.42982068413 601.301166806 5.11408436183 -4.43482068413 590.473091194 5.11408436183 -4.43982068413 581.814882764 5.11408436183 -4.44482068413 574.316652634 5.11408436183 -4.44982068413 569.371088571 5.11408436183 -4.45482068413 567.154424795 5.11408436183 -4.45982068413 567.155218213 5.11408436183 -4.46482068413 567.942979052 5.11408436183 -4.46982068413 570.63611492 5.11408436183 -4.47482068413 576.109268725 5.11408436183 -4.47982068413 584.39035475 5.11408436183 -4.48482068413 595.230054502 5.11408436183 -4.48982068413 608.785737498 5.11408436183 -4.49482068413 622.735602577 5.11408436183 -4.49982068413 638.999488932 5.11408436183 -4.50482068413 656.597323879 5.11408436183 -4.50982068413 675.004753263 5.11408436183 -4.51482068413 693.025534456 5.11408436183 -4.51982068413 713.321010408 5.11408436183 -4.52482068413 728.89604117 5.11408436183 -4.52982068413 746.857968401 5.11408436183 -4.53482068413 763.027096247 5.11408436183 -4.53982068413 775.614290206 5.11408436183 -4.54482068413 790.698604507 5.11408436183 -4.54982068413 807.924631794 5.11408436183 -4.55482068413 832.495019226 5.11408436183 -4.55982068413 844.6902956 5.11408436183 -4.56482068413 865.114834613 5.11408436183 -4.56982068413 883.577233218 5.11408436183 -4.57482068413 892.156005366 5.11408436183 -4.57982068413 921.208938729 5.11408436183 -4.58482068413 941.215605234 5.11408436183 -4.58982068413 947.484901647 5.11408436183 -4.59482068413 959.332617647 5.11408436183 -4.59982068413 965.523884961 5.11408436183 -4.60482068413 944.392110598 5.11408436183 -4.60982068413 929.050786146 5.11408436183 -4.61482068413 888.445028085 5.11408436183 -4.61982068413 910.64415944 5.11408436183 -4.62482068413 871.606684429 5.11408436183 -4.62982068413 849.329538438 5.11408436183 -4.63482068413 800.966256697 5.11408436183 -4.63982068413 746.358603726 5.11408436183 -4.64482068413 738.984828846 -0.527519427038 -4.64982068413 674.82817629 -0.715180919622 -4.65482068413 647.516153784 -0.715180919622 -4.65982068413 664.976255481 -0.715180919622 -4.66482068413 630.279457202 -0.715180919622 -4.66982068413 599.344391554 -0.715180919622 -4.67482068413 563.902642937 -0.715180919622 -4.67982068413 541.818619752 -0.715180919622 -4.68482068413 493.20017721 -0.715180919622 -4.68982068413 454.783278955 -0.715180919622 -4.69482068413 435.498242612 -0.715180919622 -4.69982068413 400.416845026 -0.715180919622 -4.70482068413 364.188366509 -0.715180919622 -4.70982068413 321.276757819 -0.715180919622 -4.71482068413 299.618624206 -0.715180919622 -4.71982068413 282.886467692 -0.715180919622 -4.72482068413 267.164598831 -0.715180919622 -4.72982068413 257.251629141 -0.715180919622 -4.73482068413 252.296440115 -0.715180919622 -4.73982068413 255.126529446 -0.715180919622 -4.74482068413 258.49680416 -0.715180919622 -4.74982068413 264.21947988 -0.715180919622 -4.75482068413 454.276391148 -0.715180919622 -4.75982068413 414.420399285 -0.715180919622 -4.76482068413 355.392100979 -0.715180919622 -4.76982068413 324.608305033 -0.715180919622 -4.77482068413 287.633773667 -0.715180919622 -4.77982068413 247.222388988 -0.715180919622 -4.78482068413 229.536774776 -0.715180919622 -4.78982068413 241.383760025 -0.715180919622 -4.79482068413 270.055240548 -0.715180919622 -4.79982068413 286.891426899 -0.715180919622 -4.80482068413 301.637189255 -0.715180919622 -4.80982068413 331.010861783 -0.715180919622 -4.81482068413 377.555606728 -0.715180919622 -4.81982068413 398.856685683 -0.715180919622 -4.82482068413 414.709870799 -0.715180919622 -4.82982068413 428.917060075 -0.715180919622 -4.83482068413 446.28157022 -0.715180919622 -4.83982068413 460.198479135 -0.715180919622 -4.84482068413 463.743837232 -0.715180919622 -4.84982068413 459.575237516 -0.715180919622 -4.85482068413 465.178113785 -0.715180919622 -4.85982068413 457.38096384 -0.715180919622 -4.86482068413 451.292997838 -0.715180919622 -4.86982068413 437.419628451 -0.715180919622 -4.87482068413 424.909444064 -0.715180919622 -4.87982068413 411.696601405 -0.715180919622 -4.88482068413 378.985693751 -0.715180919622 -4.88982068413 362.189709341 -0.715180919622 -4.89482068413 347.606233484 -0.715180919622 -4.89982068413 324.661657212 -0.715180919622 -4.90482068413 312.764107745 -0.715180919622 -4.90982068413 295.879307794 -0.715180919622 -4.91482068413 294.268226724 -0.715180919622 -4.91982068413 290.22286348 -0.715180919622 -4.92482068413 298.436286919 -0.715180919622 -4.92982068413 298.371820438 -0.715180919622 -4.93482068413 319.093233114 -0.715180919622 -4.93982068413 314.521857891 -0.715180919622 -4.94482068413 309.646256218 -0.715180919622 -4.94982068413 323.222848901 -0.715180919622 -4.95482068413 316.359261383 -0.715180919622 -4.95982068413 314.377093285 -0.715180919622 -4.96482068413 319.098828483 -0.715180919622 -4.96982068413 321.667620009 -0.715180919622 -4.97482068413 319.722873826 -0.715180919622 -4.97982068413 315.501410883 -0.715180919622 -4.98482068413 311.575879446 -0.715180919622 -4.98982068413 309.920895612 -0.715180919622 -4.99482068413 306.776860806 -0.715180919622 -4.99982068413 305.74869264 -0.715180919622 -5.00482068413 297.028093115 -0.715180919622 -5.00982068413 287.711454491 -0.715180919622 -5.01482068413 285.223071448 -0.715180919622 -5.01982068413 282.945366485 -0.715180919622 -5.02482068413 275.75820986 -0.715180919622 -5.02982068413 271.007635727 -0.715180919622 -5.03482068413 264.573342312 -0.715180919622 -5.03982068413 259.206345255 -0.715180919622 -5.04482068413 252.103679796 -0.715180919622 -5.04982068413 244.81161743 -0.715180919622 -5.05482068413 237.729868872 -0.715180919622 -5.05982068413 232.829505971 -0.715180919622 -5.06482068413 223.356910396 -0.715180919622 -5.06982068413 218.951003845 -0.715180919622 -5.07482068413 212.375567002 -0.715180919622 -5.07982068413 208.598988401 -0.715180919622 -5.08482068413 201.627312167 -0.715180919622 -5.08982068413 191.7443439 -0.715180919622 -5.09482068413 181.4153356 -0.715180919622 -5.09982068413 171.818396119 -0.715180919622 -5.10482068413 161.147305744 -0.715180919622 -5.10982068413 151.552117113 -0.715180919622 -5.11482068413 139.126361433 -0.715180919622 -5.11982068413 128.05866902 -0.715180919622 -5.12482068413 114.559580547 -0.715180919622 -5.12982068413 104.396259497 -0.715180919622 -5.13482068413 96.5480362421 -0.715180919622 -5.13982068413 86.7267570046 -0.715180919622 -5.14482068413 69.4707393481 -0.715180919622 -5.14982068413 58.1366734504 -0.715180919622 -5.15482068413 47.7793786325 -0.715180919622 -5.15982068413 39.0959929379 -0.715180919622 -5.16482068413 30.0283487512 -0.715180919622 -5.16982068413 22.5147922669 -0.715180919622 -5.17482068413 12.3101834572 -0.715180919622 -5.17982068413 7.50875357407 -0.715180919622 -5.18482068413 0.0355802160609 -0.715180919622 -5.18982068413 -6.1369233105 -0.715180919622 -5.19482068413 -11.1319676574 -0.715180919622 -5.19982068413 -14.7858727187 -0.715180919622 -5.20482068413 -18.12173235 -0.715180919622 -5.20982068413 -23.9920997213 -0.715180919622 -5.21482068413 -34.6969591209 -0.715180919622 -5.21982068413 -42.0974104649 -0.715180919622 -5.22482068413 -51.6218321181 -0.715180919622 -5.22982068413 -59.5076953776 -0.715180919622 -5.23482068413 -59.5076953776 -0.715180919622 -5.23982068413 -59.5076953776 -0.715180919622 -5.24482068413 -59.5076953776 -0.715180919622 -5.24982068413 -59.5076953776 -0.715180919622 -5.25482068413 -59.5076953776 -0.715180919622 -5.25982068413 -59.5076953776 -0.715180919622 -5.26482068413 -59.5076953776 -0.715180919622 -5.26982068413 -59.5076953776 -0.715180919622 -5.27482068413 -59.5076953776 -0.715180919622 -5.27982068413 -59.5076953776 -0.715180919622 -5.28482068413 -59.5076953776 -0.715180919622 -5.28982068413 -59.5076953776 -0.715180919622 -5.29482068413 -59.5076953776 -0.715180919622 -5.29982068413 -59.5076953776 -0.715180919622 -5.30482068413 -59.5076953776 -0.715180919622 -5.30982068413 -59.5076953776 -0.715180919622 -5.31482068413 -59.5076953776 -0.715180919622 -5.31982068413 -59.5076953776 -0.715180919622 -5.32482068413 -59.5076953776 -0.715180919622 -5.32982068413 -59.5076953776 -0.715180919622 -5.33482068413 -59.5076953776 -0.715180919622 -5.33982068413 -59.5076953776 -0.715180919622 -5.34482068413 -59.5076953776 -0.715180919622 -5.34982068413 -59.5076953776 -0.715180919622 -5.35482068413 -59.5076953776 -0.715180919622 -5.35982068413 -59.5076953776 -0.715180919622 -5.36482068413 -59.5076953776 -0.715180919622 -5.36982068413 -59.5076953776 -0.715180919622 -5.37482068413 -59.5076953776 -0.715180919622 -5.37982068413 -59.5076953776 -0.715180919622 -5.38482068413 -59.5076953776 -0.715180919622 -5.38982068413 -59.5076953776 -0.715180919622 -5.39482068413 -59.5076953776 -0.715180919622 -5.39982068413 -59.5076953776 -0.715180919622 -5.40482068413 -59.5076953776 -0.715180919622 -5.40982068413 -59.5076953776 -0.715180919622 -5.41482068413 -59.5076953776 -0.715180919622 -5.41982068413 -59.5076953776 -0.715180919622 -5.42482068413 -59.5076953776 -0.715180919622 -5.42982068413 -59.5076953776 -0.715180919622 -5.43482068413 -59.5076953776 -0.715180919622 -5.43982068413 -59.5076953776 -0.715180919622 -5.44482068413 -59.5076953776 -0.715180919622 -5.44982068413 -59.5076953776 -0.715180919622 -5.45482068413 -59.5076953776 -0.715180919622 -5.45982068413 -59.5076953776 -0.715180919622 -5.46482068413 -59.5076953776 -0.715180919622 -5.46982068413 -59.5076953776 -0.715180919622 -5.47482068413 -59.5076953776 -0.715180919622 -5.47982068413 -59.5076953776 -0.715180919622 -5.48482068413 -59.5076953776 -0.715180919622 -5.48982068413 -59.5076953776 -0.715180919622 -5.49482068413 -59.5076953776 -0.715180919622 -5.49982068413 -59.5076953776 -0.715180919622 -5.50482068413 -59.5076953776 -0.715180919622 -5.50982068413 -59.5076953776 -0.715180919622 -5.51482068413 -59.5076953776 -0.715180919622 -5.51982068413 -59.5076953776 -0.715180919622 -5.52482068413 -59.5076953776 -0.715180919622 -5.52982068413 -59.5076953776 -0.715180919622 -5.53482068413 -59.5076953776 -0.715180919622 -5.53982068413 -59.5076953776 -0.715180919622 -5.54482068413 -59.5076953776 -0.715180919622 -5.54982068413 -59.5076953776 -0.715180919622 -5.55482068413 -59.5076953776 -0.715180919622 -5.55982068413 -59.5076953776 -0.715180919622 -5.56482068413 -59.5076953776 -0.715180919622 -5.56982068413 -59.5076953776 -0.715180919622 -5.57482068413 -59.5076953776 -0.715180919622 -5.57982068413 -59.5076953776 -0.715180919622 -5.58482068413 -59.5076953776 -0.715180919622 -5.58982068413 -59.5076953776 -0.715180919622 -5.59482068413 -59.5076953776 -0.715180919622 -5.59982068413 -59.5076953776 -0.715180919622 -5.60482068413 -59.5076953776 -0.715180919622 -5.60982068413 -59.5076953776 -0.715180919622 -5.61482068413 -59.5076953776 -0.715180919622 -5.61982068413 -59.5076953776 -0.715180919622 -5.62482068413 -59.5076953776 -0.715180919622 -5.62982068413 -59.5076953776 -0.715180919622 -5.63482068413 -59.5076953776 -0.715180919622 -5.63982068413 -59.5076953776 -0.715180919622 -5.64482068413 -59.5076953776 -0.715180919622 -5.64982068413 -59.5076953776 -0.715180919622 -5.65482068413 -59.5076953776 -0.715180919622 -5.65982068413 -59.5076953776 -0.715180919622 -5.66482068413 -59.5076953776 -0.715180919622 -5.66982068413 -59.5076953776 -0.715180919622 -5.67482068413 -59.5076953776 -0.715180919622 -5.67982068413 -59.5076953776 -0.715180919622 -5.68482068413 -59.5076953776 -0.715180919622 -5.68982068413 -59.5076953776 -0.715180919622 -5.69482068413 -59.5076953776 -0.715180919622 -5.69982068413 -59.5076953776 -0.715180919622 -5.70482068413 -59.5076953776 -0.715180919622 -5.70982068413 -59.5076953776 -0.715180919622 -5.71482068413 -59.5076953776 -0.715180919622 -5.71982068413 -59.5076953776 -0.715180919622 -5.72482068413 -59.5076953776 -0.715180919622 -5.72982068413 -59.5076953776 -0.715180919622 -5.73482068413 -59.5076953776 -0.715180919622 -5.73982068413 -59.5076953776 -0.715180919622 -5.74482068413 -59.5076953776 -0.715180919622 -5.74982068413 -59.5076953776 -0.715180919622 -5.75482068413 -59.5076953776 -0.715180919622 -5.75982068413 -59.5076953776 -0.715180919622 -5.76482068413 -59.5076953776 -0.715180919622 -5.76982068413 -59.5076953776 -0.715180919622 -5.77482068413 -59.5076953776 -0.715180919622 -5.77982068413 -59.5076953776 -0.715180919622 -5.78482068413 -59.5076953776 -0.715180919622 -5.78982068413 -59.5076953776 -0.715180919622 -5.79482068413 -59.5076953776 -0.715180919622 -5.79982068413 -59.5076953776 -0.715180919622 -5.80482068413 -59.5076953776 -0.715180919622 -5.80982068413 -59.5076953776 -0.715180919622 -5.81482068413 -59.5076953776 -0.715180919622 -5.81982068413 -59.5076953776 -0.715180919622 -5.82482068413 -59.5076953776 -0.715180919622 -5.82982068413 -59.5076953776 -0.715180919622 -5.83482068413 -59.5076953776 -0.715180919622 -5.83982068413 -59.5076953776 -0.715180919622 -5.84482068413 -59.5076953776 -0.715180919622 -5.84982068413 -59.5076953776 -0.715180919622 -5.85482068413 -59.5076953776 -0.715180919622 -5.85982068413 -59.5076953776 -0.715180919622 -5.86482068413 -59.5076953776 -0.715180919622 -5.86982068413 -59.5076953776 -0.715180919622 -5.87482068413 -59.5076953776 -0.715180919622 -5.87982068413 -59.5076953776 -0.715180919622 -5.88482068413 -59.5076953776 -0.715180919622 -5.88982068413 -59.5076953776 -0.715180919622 -5.89482068413 -59.5076953776 -0.715180919622 -5.89982068413 -59.5076953776 -0.715180919622 -5.90482068413 -59.5076953776 -0.715180919622 -5.90982068413 -59.5076953776 -0.715180919622 -5.91482068413 -59.5076953776 -0.715180919622 -5.91982068413 -59.5076953776 -0.715180919622 -5.92482068413 -59.5076953776 -0.715180919622 -5.92982068413 -59.5076953776 -0.715180919622 -5.93482068413 -59.5076953776 -0.715180919622 -5.93982068413 -59.5076953776 -0.715180919622 -5.94482068413 -59.5076953776 -0.715180919622 -5.94982068413 -59.5076953776 -0.715180919622 -5.95482068413 -59.5076953776 -0.715180919622 -5.95982068413 -59.5076953776 -0.715180919622 -5.96482068413 -59.5076953776 -0.715180919622 -5.96982068413 -59.5076953776 -0.715180919622 -5.97482068413 -59.5076953776 -0.715180919622 -5.97982068413 -59.5076953776 -0.715180919622 -5.98482068413 -59.5076953776 -0.715180919622 -5.98982068413 -59.5076953776 -0.715180919622 -5.99482068413 -59.5076953776 -0.715180919622 -5.99982068413 -59.5076953776 -0.715180919622 -6.00482068413 -59.5076953776 -0.715180919622 -6.00982068413 -59.5076953776 -0.715180919622 -6.01482068413 -59.5076953776 -0.715180919622 -6.01982068413 -59.5076953776 -0.715180919622 -6.02482068413 -59.5076953776 -0.715180919622 -6.02982068413 -59.5076953776 -0.715180919622 -6.03482068413 -59.5076953776 -0.715180919622 -6.03982068413 -59.5076953776 -0.715180919622 -6.04482068413 -59.5076953776 -0.715180919622 -6.04982068413 -59.5076953776 -0.715180919622 -6.05482068413 -59.5076953776 -0.715180919622 -6.05982068413 -59.5076953776 -0.715180919622 -6.06482068413 -59.5076953776 -0.715180919622 -6.06982068413 -59.5076953776 -0.715180919622 -6.07482068413 -59.5076953776 -0.715180919622 -6.07982068413 -59.5076953776 -0.715180919622 -6.08482068413 -59.5076953776 -0.715180919622 -6.08982068413 -59.5076953776 -0.715180919622 -6.09482068413 -59.5076953776 -0.715180919622 -6.09982068413 -59.5076953776 -0.715180919622 -6.10482068413 -59.5076953776 -0.715180919622 -6.10982068413 -59.5076953776 -0.715180919622 -6.11482068413 -59.5076953776 -0.715180919622 -6.11982068413 -59.5076953776 -0.715180919622 -6.12482068413 -59.5076953776 -0.715180919622 -6.12982068413 -59.5076953776 -0.715180919622 -6.13482068413 -59.5076953776 -0.715180919622 -6.13982068413 -59.5076953776 -0.715180919622 -6.14482068413 -59.5076953776 -0.715180919622 -6.14982068413 -59.5076953776 -0.715180919622 -6.15482068413 -59.5076953776 -0.715180919622 -6.15982068413 798.554606778 -0.715180919622 -6.16482068413 328.268727495 -0.715180919622 -6.16982068413 132.201194315 -0.715180919622 -6.17482068413 -219.099856507 -0.715180919622 -6.17982068413 92.6985531346 -0.715180919622 -6.18482068413 870.388117863 -0.715180919622 -6.18982068413 1704.01686569 -0.715180919622 -6.19482068413 1779.71198768 -0.715180919622 -6.19982068413 1543.21700339 -0.715180919622 -6.20482068413 1361.75423663 -0.715180919622 -6.20982068413 1014.43180956 -0.715180919622 -6.21482068413 1033.57701216 -0.715180919622 -6.21982068413 810.426930861 -0.715180919622 -6.22482068413 634.910954651 -0.715180919622 -6.22982068413 579.5941707 -0.715180919622 -6.23482068413 493.454331288 -0.715180919622 -6.23982068413 465.778744655 -0.715180919622 -6.24482068413 428.641431138 -0.715180919622 -6.24982068413 412.767221818 -0.715180919622 -6.25482068413 434.142577376 -0.715180919622 -6.25982068413 478.266947584 -0.715180919622 -6.26482068413 504.880840536 -0.715180919622 -6.26982068413 519.510410012 -0.715180919622 -6.27482068413 524.21112833 -0.715180919622 -6.27982068413 544.923050991 -0.715180919622 -6.28482068413 548.160537438 -0.715180919622 -6.28982068413 537.911221811 -0.715180919622 -6.29482068413 551.012031793 -0.715180919622 -6.29982068413 552.586244559 -0.715180919622 -6.30482068413 561.266542485 -0.715180919622 -6.30982068413 565.722318028 -0.715180919622 -6.31482068413 572.541827038 -0.715180919622 -6.31982068413 515.668730721 -0.715180919622 -6.32482068413 551.681298836 -0.715180919622 -6.32982068413 558.366616579 -0.715180919622 -6.33482068413 570.812749876 -0.715180919622 -6.33982068413 583.435269931 -0.715180919622 -6.34482068413 592.399151743 -0.715180919622 -6.34982068413 598.064761356 -0.715180919622 -6.35482068413 600.034497482 -0.715180919622 -6.35982068413 600.989944602 -0.715180919622 -6.36482068413 600.229809891 -0.715180919622 -6.36982068413 595.222370139 -0.715180919622 -6.37482068413 592.016457221 -0.715180919622 -6.37982068413 587.85454356 -0.715180919622 -6.38482068413 583.029657182 -0.715180919622 -6.38982068413 578.952390404 -0.715180919622 -6.39482068413 572.351105671 -0.715180919622 -6.39982068413 569.070074268 -0.715180919622 -6.40482068413 569.697491957 -0.715180919622 -6.40982068413 570.433530621 -0.715180919622 -6.41482068413 575.126832712 -0.715180919622 -6.41982068413 585.8327573 -0.715180919622 -6.42482068413 597.433604726 -0.715180919622 -6.42982068413 610.327958872 -0.715180919622 -6.43482068413 625.545861808 -0.715180919622 -6.43982068413 640.081671634 -0.715180919622 -6.44482068413 656.931963111 -0.715180919622 -6.44982068413 675.859399844 -0.715180919622 -6.45482068413 690.822910963 -0.715180919622 -6.45982068413 710.464741221 -0.715180919622 -6.46482068413 731.996962156 -0.715180919622 -6.46982068413 751.515202492 -0.715180919622 -6.47482068413 771.257365552 -0.715180919622 -6.47982068413 799.449820149 -0.715180919622 -6.48482068413 828.841457903 -0.715180919622 -6.48982068413 862.654907289 -0.715180919622 -6.49482068413 884.398483294 -0.715180919622 -6.49982068413 909.084074144 -0.715180919622 -6.50482068413 970.483381089 -0.715180919622 -6.50982068413 955.87084304 -0.715180919622 -6.51482068413 973.393062099 -0.715180919622 -6.51982068413 988.419405574 -0.715180919622 -6.52482068413 963.047203154 -0.715180919622 -6.52982068413 934.568657307 -0.715180919622 -6.53482068413 891.025511731 -0.715180919622 -6.53982068413 863.567364336 -0.715180919622 -6.54482068413 827.577015014 -0.715180919622 -6.54982068413 789.620910397 -0.715180919622 -6.55482068413 754.331720012 -0.715180919622 -6.55982068413 706.451791091 -0.715180919622 -6.56482068413 672.009325605 -0.715180919622 -6.56982068413 637.297547354 -0.715180919622 -6.57482068413 600.080198349 -0.715180919622 -6.57982068413 573.007434596 -0.715180919622 -6.58482068413 546.936894199 -0.715180919622 -6.58982068413 527.071917621 -0.715180919622 -6.59482068413 504.241438557 -0.715180919622 -6.59982068413 493.273095787 -0.715180919622 -6.60482068413 476.723266148 -0.715180919622 -6.60982068413 463.943734386 -0.715180919622 -6.61482068413 448.009335424 -0.715180919622 -6.61982068413 434.594747352 -0.715180919622 -6.62482068413 417.477767756 -0.715180919622 -6.62982068413 402.455065882 -0.715180919622 -6.63482068413 387.437591909 -0.715180919622 -6.63982068413 377.036044602 -0.715180919622 -6.64482068413 369.082374305 -0.715180919622 -6.64982068413 366.530588875 -0.715180919622 -6.65482068413 366.538602836 -0.715180919622 -6.65982068413 378.426711398 -0.715180919622 -6.66482068413 385.409900414 -0.715180919622 -6.66982068413 389.148170696 -0.715180919622 -6.67482068413 391.30984959 -0.715180919622 -6.67982068413 395.457781685 -0.715180919622 -6.68482068413 399.304538984 -0.715180919622 -6.68982068413 402.725400626 -0.715180919622 -6.69482068413 406.900569499 -0.715180919622 -6.69982068413 410.365981537 -0.715180919622 -6.70482068413 411.375708165 -0.715180919622 -6.70982068413 414.224470892 -0.715180919622 -6.71482068413 423.789901963 -0.715180919622 -6.71982068413 420.496795949 -0.715180919622 -6.72482068413 416.795022644 -0.715180919622 -6.72982068413 413.52543652 -0.715180919622 -6.73482068413 411.470226085 -0.715180919622 -6.73982068413 414.495323529 -0.715180919622 -6.74482068413 418.659851792 -0.715180919622 -6.74982068413 423.148073706 -0.715180919622 -6.75482068413 421.920813797 -0.715180919622 -6.75982068413 424.128303674 -0.715180919622 -6.76482068413 425.958756011 -0.715180919622 -6.76982068413 426.1178486 -0.715180919622 -6.77482068413 417.053116194 -0.715180919622 -6.77982068413 411.184939813 -0.715180919622 -6.78482068413 417.141091811 -0.715180919622 -6.78982068413 408.603136189 -0.715180919622 -6.79482068413 403.487146518 -0.715180919622 -6.79982068413 400.031338763 -0.715180919622 -6.80482068413 391.589044987 -0.715180919622 -6.80982068413 385.985355896 -0.715180919622 -6.81482068413 381.528956743 -0.715180919622 -6.81982068413 374.57995478 -0.715180919622 -6.82482068413 371.108444643 -0.715180919622 -6.82982068413 365.376213539 -0.715180919622 -6.83482068413 362.908495269 -0.715180919622 -6.83982068413 361.663494329 -0.715180919622 -6.84482068413 361.970891714 -0.715180919622 -6.84982068413 359.616383678 -0.715180919622 -6.85482068413 356.491306215 -0.715180919622 -6.85982068413 354.998913962 -0.715180919622 -6.86482068413 355.341795245 -0.715180919622 -6.86982068413 357.108332874 -0.715180919622 -6.87482068413 355.575477083 -0.715180919622 -6.87982068413 350.834099838 -0.715180919622 -6.88482068413 350.550460757 -0.715180919622 -6.88982068413 347.184002176 -0.715180919622 -6.89482068413 345.512973735 -0.715180919622 -6.89982068413 339.265723323 -0.715180919622 -6.90482068413 335.378918557 -0.715180919622 -6.90982068413 332.704751962 -0.715180919622 -6.91482068413 328.509266186 -0.715180919622 -6.91982068413 322.463712069 -0.715180919622 -6.92482068413 316.744502245 -0.715180919622 -6.92982068413 312.038575141 -0.715180919622 -6.93482068413 305.682637686 -0.715180919622 -6.93982068413 299.050309382 -0.715180919622 -6.94482068413 293.215671826 -0.715180919622 -6.94982068413 288.760531197 -0.715180919622 -6.95482068413 286.328202983 -0.715180919622 -6.95982068413 281.1822825 -0.715180919622 -6.96482068413 274.646778248 -0.715180919622 -6.96982068413 266.602716534 -0.715180919622 -6.97482068413 256.868913736 -0.715180919622 -6.97982068413 248.664771384 -0.715180919622 -6.98482068413 239.076035965 -0.715180919622 -6.98982068413 226.60946587 -0.715180919622 -6.99482068413 221.078823356 -0.715180919622 -6.99982068413 213.25705241 -0.715180919622 -7.00482068413 205.205540186 -0.715180919622 -7.00982068413 195.751463085 -0.715180919622 -7.01482068413 186.996894246 -0.715180919622 -7.01982068413 177.054331248 -0.715180919622 -7.02482068413 168.138870562 -0.715180919622 -7.02982068413 167.222827797 -0.715180919622 -7.03482068413 156.323137168 -0.715180919622 -7.03982068413 142.40266752 -0.715180919622 -7.04482068413 133.588558749 -0.715180919622 -7.04982068413 128.066524736 -0.715180919622 -7.05482068413 118.379855736 -0.715180919622 -7.05982068413 109.543385779 -0.715180919622 -7.06482068413 95.9281330351 -0.715180919622 -7.06982068413 84.9096412992 -0.715180919622 -7.07482068413 74.7442591127 -0.715180919622 -7.07982068413 62.7166537745 -0.715180919622 -7.08482068413 52.7922093481 -0.715180919622 -7.08982068413 44.542831759 -0.715180919622 -7.09482068413 18.1696176607 -0.715180919622 -7.09982068413 -18.9739394831 -0.715180919622 -7.10482068413 -19.3103103051 -0.715180919622 -7.10982068413 7.77301412559 -0.715180919622 -7.11482068413 15.2083151915 -0.715180919622 -7.11982068413 8.14955791665 -0.715180919622 -7.12482068413 -11.2799405419 -0.715180919622 -7.12982068413 -8.08182063526 -0.715180919622 -7.13482068413 -21.3125430884 -0.715180919622 -7.13982068413 -26.9820663755 -0.715180919622 -7.14482068413 -40.2985280955 -0.715180919622 -7.14982068413 -54.008232421 -0.715180919622 -7.15482068413 -54.008232421 -0.715180919622 -7.15982068413 -54.008232421 -0.715180919622 -7.16482068413 -54.008232421 -0.715180919622 -7.16982068413 -54.008232421 -0.715180919622 -7.17482068413 -54.008232421 -0.715180919622 -7.17982068413 -54.008232421 -0.715180919622 -7.18482068413 -54.008232421 -0.715180919622 -7.18982068413 -54.008232421 -0.715180919622 -7.19482068413 -54.008232421 -0.715180919622 -7.19982068413 -54.008232421 -0.715180919622 -7.20482068413 -54.008232421 -0.715180919622 -7.20982068413 -54.008232421 -0.715180919622 -7.21482068413 -54.008232421 -0.715180919622 -7.21982068413 -54.008232421 -0.715180919622 -7.22482068413 -54.008232421 -0.715180919622 -7.22982068413 -54.008232421 -0.715180919622 -7.23482068413 -54.008232421 -0.715180919622 -7.23982068413 -54.008232421 -0.715180919622 -7.24482068413 -54.008232421 -0.715180919622 -7.24982068413 -54.008232421 -0.715180919622 -7.25482068413 -54.008232421 -0.715180919622 -7.25982068413 -54.008232421 -0.715180919622 -7.26482068413 -54.008232421 -0.715180919622 -7.26982068413 -54.008232421 -0.715180919622 -7.27482068413 -54.008232421 -0.715180919622 -7.27982068413 -54.008232421 -0.715180919622 -7.28482068413 -54.008232421 -0.715180919622 -7.28982068413 -54.008232421 -0.715180919622 -7.29482068413 -54.008232421 -0.715180919622 -7.29982068413 -54.008232421 -0.715180919622 -7.30482068413 -54.008232421 -0.715180919622 -7.30982068413 -54.008232421 -0.715180919622 -7.31482068413 -54.008232421 -0.715180919622 -7.31982068413 -54.008232421 -0.715180919622 -7.32482068413 -54.008232421 -0.715180919622 -7.32982068413 -54.008232421 -0.715180919622 -7.33482068413 -54.008232421 -0.715180919622 -7.33982068413 -54.008232421 -0.715180919622 -7.34482068413 -54.008232421 -0.715180919622 -7.34982068413 -54.008232421 -0.715180919622 -7.35482068413 -54.008232421 -0.715180919622 -7.35982068413 -54.008232421 -0.715180919622 -7.36482068413 -54.008232421 -0.715180919622 -7.36982068413 -54.008232421 -0.715180919622 -7.37482068413 -54.008232421 -0.715180919622 -7.37982068413 -54.008232421 -0.715180919622 -7.38482068413 -54.008232421 -0.715180919622 -7.38982068413 -54.008232421 -0.715180919622 -7.39482068413 -54.008232421 -0.715180919622 -7.39982068413 -54.008232421 -0.715180919622 -7.40482068413 -54.008232421 -0.715180919622 -7.40982068413 -54.008232421 -0.715180919622 -7.41482068413 -54.008232421 -0.715180919622 -7.41982068413 -54.008232421 -0.715180919622 -7.42482068413 -54.008232421 -0.715180919622 -7.42982068413 -54.008232421 -0.715180919622 -7.43482068413 -54.008232421 -0.715180919622 -7.43982068413 -54.008232421 -0.715180919622 -7.44482068413 -54.008232421 -0.715180919622 -7.44982068413 -54.008232421 -0.715180919622 -7.45482068413 -54.008232421 -0.715180919622 -7.45982068413 -54.008232421 -0.715180919622 -7.46482068413 -54.008232421 -0.715180919622 -7.46982068413 -54.008232421 -0.715180919622 -7.47482068413 -54.008232421 -0.715180919622 -7.47982068413 -54.008232421 -0.715180919622 -7.48482068413 -54.008232421 -0.715180919622 -7.48982068413 -54.008232421 -0.715180919622 -7.49482068413 -54.008232421 -0.715180919622 -7.49982068413 -54.008232421 -0.715180919622 -7.50482068413 -54.008232421 -0.715180919622 -7.50982068413 -54.008232421 -0.715180919622 -7.51482068413 -54.008232421 -0.715180919622 -7.51982068413 -54.008232421 -0.715180919622 -7.52482068413 -54.008232421 -0.715180919622 -7.52982068413 -54.008232421 -0.715180919622 -7.53482068413 -54.008232421 -0.715180919622 -7.53982068413 -54.008232421 -0.715180919622 -7.54482068413 -54.008232421 -0.715180919622 -7.54982068413 -54.008232421 -0.715180919622 -7.55482068413 -54.008232421 -0.715180919622 -7.55982068413 -54.008232421 -0.715180919622 -7.56482068413 -54.008232421 -0.715180919622 -7.56982068413 -54.008232421 -0.715180919622 -7.57482068413 -54.008232421 -0.715180919622 -7.57982068413 -54.008232421 -0.715180919622 -7.58482068413 -54.008232421 -0.715180919622 -7.58982068413 -54.008232421 -0.715180919622 -7.59482068413 -54.008232421 -0.715180919622 -7.59982068413 -54.008232421 -0.715180919622 -7.60482068413 -54.008232421 -0.715180919622 -7.60982068413 -54.008232421 -0.715180919622 -7.61482068413 -54.008232421 -0.715180919622 -7.61982068413 -54.008232421 -0.715180919622 -7.62482068413 -54.008232421 -0.715180919622 -7.62982068413 -54.008232421 -0.715180919622 -7.63482068413 -54.008232421 -0.715180919622 -7.63982068413 -54.008232421 -0.715180919622 -7.64482068413 -54.008232421 -0.715180919622 -7.64982068413 -54.008232421 -0.715180919622 -7.65482068413 -54.008232421 -0.715180919622 -7.65982068413 -54.008232421 -0.715180919622 -7.66482068413 -54.008232421 -0.715180919622 -7.66982068413 -54.008232421 -0.715180919622 -7.67482068413 -54.008232421 -0.715180919622 -7.67982068413 -54.008232421 -0.715180919622 -7.68482068413 -54.008232421 -0.715180919622 -7.68982068413 -54.008232421 -0.715180919622 -7.69482068413 -54.008232421 -0.715180919622 -7.69982068413 -54.008232421 -0.715180919622 -7.70482068413 -54.008232421 -0.715180919622 -7.70982068413 -54.008232421 -0.715180919622 -7.71482068413 -54.008232421 -0.715180919622 -7.71982068413 -54.008232421 -0.715180919622 -7.72482068413 -54.008232421 -0.715180919622 -7.72982068413 -54.008232421 -0.715180919622 -7.73482068413 -54.008232421 -0.715180919622 -7.73982068413 -54.008232421 -0.715180919622 -7.74482068413 -54.008232421 -0.715180919622 -7.74982068413 -54.008232421 -0.715180919622 -7.75482068413 -54.008232421 -0.715180919622 -7.75982068413 -54.008232421 -0.715180919622 -7.76482068413 -54.008232421 -0.715180919622 -7.76982068413 -54.008232421 -0.715180919622 -7.77482068413 -54.008232421 -0.715180919622 -7.77982068413 -54.008232421 -0.715180919622 -7.78482068413 -54.008232421 -0.715180919622 -7.78982068413 -54.008232421 -0.715180919622 -7.79482068413 -54.008232421 -0.715180919622 -7.79982068413 -54.008232421 -0.715180919622 -7.80482068413 -54.008232421 -0.715180919622 -7.80982068413 -54.008232421 -0.715180919622 -7.81482068413 -54.008232421 -0.715180919622 -7.81982068413 -54.008232421 -0.715180919622 -7.82482068413 -54.008232421 -0.715180919622 -7.82982068413 -54.008232421 -0.715180919622 -7.83482068413 -54.008232421 -0.715180919622 -7.83982068413 -54.008232421 -0.715180919622 -7.84482068413 -54.008232421 -0.715180919622 -7.84982068413 -54.008232421 -0.715180919622 -7.85482068413 -54.008232421 -0.715180919622 -7.85982068413 -54.008232421 -0.715180919622 -7.86482068413 -54.008232421 -0.715180919622 -7.86982068413 -54.008232421 -0.715180919622 -7.87482068413 -54.008232421 -0.715180919622 -7.87982068413 -54.008232421 -0.715180919622 -7.88482068413 -54.008232421 -0.715180919622 -7.88982068413 -54.008232421 -0.715180919622 -7.89482068413 -54.008232421 -0.715180919622 -7.89982068413 -54.008232421 -0.715180919622 -7.90482068413 -54.008232421 -0.715180919622 -7.90982068413 -54.008232421 -0.715180919622 -7.91482068413 -54.008232421 -0.715180919622 -7.91982068413 -54.008232421 -0.715180919622 -7.92482068413 -54.008232421 -0.715180919622 -7.92982068413 -54.008232421 -0.715180919622 -7.93482068413 -54.008232421 -0.715180919622 -7.93982068413 -54.008232421 -0.715180919622 -7.94482068413 -54.008232421 -0.715180919622 -7.94982068413 -54.008232421 -0.715180919622 -7.95482068413 -54.008232421 -0.715180919622 -7.95982068413 -54.008232421 -0.715180919622 -7.96482068413 -54.008232421 -0.715180919622 -7.96982068413 -54.008232421 -0.715180919622 -7.97482068413 -54.008232421 -0.715180919622 -7.97982068413 -54.008232421 -0.715180919622 -7.98482068413 -54.008232421 -0.715180919622 -7.98982068413 -54.008232421 -0.715180919622 -7.99482068413 -54.008232421 -0.715180919622 -7.99982068413 -54.008232421 -0.715180919622 -8.00482068413 -54.008232421 -0.715180919622 -8.00982068413 -54.008232421 -0.715180919622 -8.01482068413 -54.008232421 -0.715180919622 -8.01982068413 -54.008232421 -0.715180919622 -8.02482068413 -54.008232421 -0.715180919622 -8.02982068413 -54.008232421 -0.715180919622 -8.03482068413 -54.008232421 -0.715180919622 -8.03982068413 -54.008232421 -0.715180919622 -8.04482068413 -54.008232421 -0.715180919622 -8.04982068413 -54.008232421 -0.715180919622 -8.05482068413 -54.008232421 -0.715180919622 -8.05982068413 -54.008232421 -0.715180919622 -8.06482068413 -54.008232421 -0.715180919622 -8.06982068413 -54.008232421 -0.715180919622 -8.07482068413 -54.008232421 -0.715180919622 -8.07982068413 -54.008232421 -0.715180919622 -8.08482068413 -54.008232421 -0.715180919622 -8.08982068413 -54.008232421 -0.715180919622 -8.09482068413 -54.008232421 -0.715180919622 -8.09982068413 -54.008232421 -0.715180919622 -8.10482068413 -54.008232421 -0.715180919622 -8.10982068413 -54.008232421 -0.715180919622 -8.11482068413 -54.008232421 -0.715180919622 -8.11982068413 671.363126485 -0.715180919622 -8.12482068413 1675.19942355 -0.715180919622 -8.12982068413 2075.92418063 -0.715180919622 -8.13482068413 2330.34203385 -0.715180919622 -8.13982068413 2194.84206415 -0.715180919622 -8.14482068413 1888.33417594 -0.715180919622 -8.14982068413 1533.51623536 -0.715180919622 -8.15482068413 1285.32777571 -0.715180919622 -8.15982068413 1096.7798073 -0.715180919622 -8.16482068413 940.135449142 -0.715180919622 -8.16982068413 791.535399342 -0.715180919622 -8.17482068413 646.720309256 -0.715180919622 -8.17982068413 526.690241911 -0.715180919622 -8.18482068413 446.91833886 -0.715180919622 -8.18982068413 397.565028349 -0.715180919622 -8.19482068413 377.44633083 -0.715180919622 -8.19982068413 362.349510943 -0.715180919622 -8.20482068413 369.207886968 -0.715180919622 -8.20982068413 388.091209414 -0.715180919622 -8.21482068413 412.168930185 2.50667026049 -8.21982068413 443.045316104 2.51569154217 -8.22482068413 471.988054506 2.4815900928 -8.22982068413 497.59773814 2.4815900928 -8.23482068413 525.171010358 2.4815900928 -8.23982068413 551.519763078 2.4815900928 -8.24482068413 574.621550974 2.4815900928 -8.24982068413 587.881320121 2.4815900928 -8.25482068413 594.09093387 2.4815900928 -8.25982068413 598.978526651 2.4815900928 -8.26482068413 594.966185086 2.4815900928 -8.26982068413 588.838313887 2.4815900928 -8.27482068413 579.324360611 2.4815900928 -8.27982068413 560.420162514 2.4815900928 -8.28482068413 540.397701448 2.4815900928 -8.28982068413 524.084764987 2.4815900928 -8.29482068413 506.172935744 2.4815900928 -8.29982068413 489.761658164 2.4815900928 -8.30482068413 478.165806597 2.4815900928 -8.30982068413 474.384262309 2.4815900928 -8.31482068413 475.072739224 2.4815900928 -8.31982068413 478.916085939 2.4815900928 -8.32482068413 485.821528463 2.4815900928 -8.32982068413 498.014415842 2.4815900928 -8.33482068413 512.93280466 2.4815900928 -8.33982068413 524.225608263 2.4815900928 -8.34482068413 538.569060517 2.4815900928 -8.34982068413 554.279563331 2.4815900928 -8.35482068413 567.010627913 2.4815900928 -8.35982068413 576.297741641 2.4815900928 -8.36482068413 588.682064123 2.4815900928 -8.36982068413 603.650111008 2.4815900928 -8.37482068413 618.808837115 2.4815900928 -8.37982068413 633.992995135 2.4815900928 -8.38482068413 664.394091991 2.4815900928 -8.38982068413 700.299342234 2.4815900928 -8.39482068413 722.723753119 2.4815900928 -8.39982068413 758.096293789 2.4815900928 -8.40482068413 794.160371109 2.4815900928 -8.40982068413 829.638852494 2.4815900928 -8.41482068413 856.851264617 2.4815900928 -8.41982068413 883.143331382 2.4815900928 -8.42482068413 906.287479348 2.4815900928 -8.42982068413 920.157734122 2.4815900928 -8.43482068413 927.624970386 2.4815900928 -8.43982068413 933.869660824 2.4815900928 -8.44482068413 925.39019615 2.4815900928 -8.44982068413 930.452703138 2.4815900928 -8.45482068413 922.816290138 2.4815900928 -8.45982068413 923.221990318 2.4815900928 -8.46482068413 919.11563099 2.4815900928 -8.46982068413 916.712360222 2.4815900928 -8.47482068413 899.509451489 2.4815900928 -8.47982068413 877.190475535 2.4815900928 -8.48482068413 844.428685242 -0.777339947265 -8.48982068413 843.829829226 -0.918919462293 -8.49482068413 809.457300872 -1.09023136704 -8.49982068413 773.986634659 -1.09023136704 -8.50482068413 738.135694138 -1.09023136704 -8.50982068413 707.539762393 -1.09023136704 -8.51482068413 641.25031974 -1.09023136704 -8.51982068413 611.9323203 -1.09023136704 -8.52482068413 575.92298925 -1.09023136704 -8.52982068413 518.432920766 -1.09023136704 -8.53482068413 459.91032272 -1.09023136704 -8.53982068413 413.534924415 -1.09023136704 -8.54482068413 328.735019161 -1.09023136704 -8.54982068413 319.755409665 -1.09023136704 -8.55482068413 312.36396112 -1.09023136704 -8.55982068413 259.968528265 -1.09023136704 -8.56482068413 230.212497667 -1.09023136704 -8.56982068413 192.347083827 -1.09023136704 -8.57482068413 173.36269392 -1.09023136704 -8.57982068413 172.210436833 -1.09023136704 -8.58482068413 153.501171164 -1.09023136704 -8.58982068413 152.942601621 -1.09023136704 -8.59482068413 490.554707223 -1.09023136704 -8.59982068413 385.60332081 -1.09023136704 -8.60482068413 253.073434964 -1.09023136704 -8.60982068413 279.442100497 -1.09023136704 -8.61482068413 297.081225035 -1.09023136704 -8.61982068413 226.643444855 -1.09023136704 -8.62482068413 199.136260099 -1.09023136704 -8.62982068413 338.350283407 -1.09023136704 -8.63482068413 339.022746929 -1.09023136704 -8.63982068413 391.590888118 -1.09023136704 -8.64482068413 414.682888192 -1.09023136704 -8.64982068413 443.478991686 -1.09023136704 -8.65482068413 456.404011601 -1.09023136704 -8.65982068413 452.303691981 -1.09023136704 -8.66482068413 433.324722775 -1.09023136704 -8.66982068413 453.379202577 -1.09023136704 -8.67482068413 444.403261522 -1.09023136704 -8.67982068413 415.941437653 -1.09023136704 -8.68482068413 401.100394428 -1.09023136704 -8.68982068413 381.298683138 -1.09023136704 -8.69482068413 369.725384509 -1.09023136704 -8.69982068413 367.917029836 -1.09023136704 -8.70482068413 371.303646877 -1.09023136704 -8.70982068413 380.545480098 -1.09023136704 -8.71482068413 388.556880217 -1.09023136704 -8.71982068413 408.506081358 -1.09023136704 -8.72482068413 418.310907455 -1.09023136704 -8.72982068413 428.852904122 -1.09023136704 -8.73482068413 439.01962849 -1.09023136704 -8.73982068413 444.903357791 -1.09023136704 -8.74482068413 455.074521265 -1.09023136704 -8.74982068413 450.802990121 -1.09023136704 -8.75482068413 447.218317237 -1.09023136704 -8.75982068413 442.337478238 -1.09023136704 -8.76482068413 433.219380583 -1.09023136704 -8.76982068413 426.011842805 -1.09023136704 -8.77482068413 422.436413282 -1.09023136704 -8.77982068413 406.794887031 -1.09023136704 -8.78482068413 398.689532389 -1.09023136704 -8.78982068413 406.822714905 -1.09023136704 -8.79482068413 394.983950304 -1.09023136704 -8.79982068413 367.190071791 -1.09023136704 -8.80482068413 361.948262643 -1.09023136704 -8.80982068413 346.735916909 -1.09023136704 -8.81482068413 339.769012045 -1.09023136704 -8.81982068413 326.839421254 -1.09023136704 -8.82482068413 320.514381942 -1.09023136704 -8.82982068413 321.226045725 -1.09023136704 -8.83482068413 314.658072068 -1.09023136704 -8.83982068413 309.681051527 -1.09023136704 -8.84482068413 304.099653725 -1.09023136704 -8.84982068413 303.857088529 -1.09023136704 -8.85482068413 306.220577293 -1.09023136704 -8.85982068413 300.096000662 -1.09023136704 -8.86482068413 298.450284379 -1.09023136704 -8.86982068413 297.955468233 -1.09023136704 -8.87482068413 292.785202387 -1.09023136704 -8.87982068413 286.454993532 -1.09023136704 -8.88482068413 283.510117148 -1.09023136704 -8.88982068413 283.997350746 -1.09023136704 -8.89482068413 277.35785323 -1.09023136704 -8.89982068413 271.113407954 -1.09023136704 -8.90482068413 266.499733124 -1.09023136704 -8.90982068413 265.163771095 -1.09023136704 -8.91482068413 260.108785648 -1.09023136704 -8.91982068413 248.820841311 -1.09023136704 -8.92482068413 244.75137721 -1.09023136704 -8.92982068413 244.70230318 -1.09023136704 -8.93482068413 232.464342121 -1.09023136704 -8.93982068413 222.982581771 -1.09023136704 -8.94482068413 211.001910828 -1.09023136704 -8.94982068413 203.878997006 -1.09023136704 -8.95482068413 192.041997531 -1.09023136704 -8.95982068413 179.268272432 -1.09023136704 -8.96482068413 167.077118029 -1.09023136704 -8.96982068413 159.067042523 -1.09023136704 -8.97482068413 142.620760281 -1.09023136704 -8.97982068413 128.783107249 -1.09023136704 -8.98482068413 117.074095891 -1.09023136704 -8.98982068413 105.319951127 -1.09023136704 -8.99482068413 95.554249334 -1.09023136704 -8.99982068413 83.545146582 -1.09023136704 -9.00482068413 64.2595430578 -1.09023136704 -9.00982068413 43.9599002164 -1.09023136704 -9.01482068413 27.5647257131 -1.09023136704 -9.01982068413 18.6408696338 -1.09023136704 -9.02482068413 -14.0068688174 -1.09023136704 -9.02982068413 -10.3577275246 -1.09023136704 -9.03482068413 -37.1106822721 -1.09023136704 -9.03982068413 -13.5177725272 -1.09023136704 -9.04482068413 -24.7951715114 -1.09023136704 -9.04982068413 -34.786144465 -1.09023136704 -9.05482068413 -43.9438510117 -1.09023136704 -9.05982068413 -50.4932266405 -1.09023136704 -9.06482068413 -50.4932266405 -1.09023136704 -9.06982068413 -50.4932266405 -1.09023136704 -9.07482068413 -50.4932266405 -1.09023136704 -9.07982068413 -50.4932266405 -1.09023136704 -9.08482068413 -50.4932266405 -1.09023136704 -9.08982068413 -50.4932266405 -1.09023136704 -9.09482068413 -50.4932266405 -1.09023136704 -9.09982068413 -50.4932266405 -1.09023136704 -9.10482068413 -50.4932266405 -1.09023136704 -9.10982068413 -50.4932266405 -1.09023136704 -9.11482068413 -50.4932266405 -1.09023136704 -9.11982068413 -50.4932266405 -1.09023136704 -9.12482068413 -50.4932266405 -1.09023136704 -9.12982068413 -50.4932266405 -1.09023136704 -9.13482068413 -50.4932266405 -1.09023136704 -9.13982068413 -50.4932266405 -1.09023136704 -9.14482068413 -50.4932266405 -1.09023136704 -9.14982068413 -50.4932266405 -1.09023136704 -9.15482068413 -50.4932266405 -1.09023136704 -9.15982068413 -50.4932266405 -1.09023136704 -9.16482068413 -50.4932266405 -1.09023136704 -9.16982068413 -50.4932266405 -1.09023136704 -9.17482068413 -50.4932266405 -1.09023136704 -9.17982068413 -50.4932266405 -1.09023136704 -9.18482068413 -50.4932266405 -1.09023136704 -9.18982068413 -50.4932266405 -1.09023136704 -9.19482068413 -50.4932266405 -1.09023136704 -9.19982068413 -50.4932266405 -1.09023136704 -9.20482068413 -50.4932266405 -1.09023136704 -9.20982068413 -50.4932266405 -1.09023136704 -9.21482068413 -50.4932266405 -1.09023136704 -9.21982068413 -50.4932266405 -1.09023136704 -9.22482068413 -50.4932266405 -1.09023136704 -9.22982068413 -50.4932266405 -1.09023136704 -9.23482068413 -50.4932266405 -1.09023136704 -9.23982068413 -50.4932266405 -1.09023136704 -9.24482068413 -50.4932266405 -1.09023136704 -9.24982068413 -50.4932266405 -1.09023136704 -9.25482068413 -50.4932266405 -1.09023136704 -9.25982068413 -50.4932266405 -1.09023136704 -9.26482068413 -50.4932266405 -1.09023136704 -9.26982068413 -50.4932266405 -1.09023136704 -9.27482068413 -50.4932266405 -1.09023136704 -9.27982068413 -50.4932266405 -1.09023136704 -9.28482068413 -50.4932266405 -1.09023136704 -9.28982068413 -50.4932266405 -1.09023136704 -9.29482068413 -50.4932266405 -1.09023136704 -9.29982068413 -50.4932266405 -1.09023136704 -9.30482068413 -50.4932266405 -1.09023136704 -9.30982068413 -50.4932266405 -1.09023136704 -9.31482068413 -50.4932266405 -1.09023136704 -9.31982068413 -50.4932266405 -1.09023136704 -9.32482068413 -50.4932266405 -1.09023136704 -9.32982068413 -50.4932266405 -1.09023136704 -9.33482068413 -50.4932266405 -1.09023136704 -9.33982068413 -50.4932266405 -1.09023136704 -9.34482068413 -50.4932266405 -1.09023136704 -9.34982068413 -50.4932266405 -1.09023136704 -9.35482068413 -50.4932266405 -1.09023136704 -9.35982068413 -50.4932266405 -1.09023136704 -9.36482068413 -50.4932266405 -1.09023136704 -9.36982068413 -50.4932266405 -1.09023136704 -9.37482068413 -50.4932266405 -1.09023136704 -9.37982068413 -50.4932266405 -1.09023136704 -9.38482068413 -50.4932266405 -1.09023136704 -9.38982068413 -50.4932266405 -1.09023136704 -9.39482068413 -50.4932266405 -1.09023136704 -9.39982068413 -50.4932266405 -1.09023136704 -9.40482068413 -50.4932266405 -1.09023136704 -9.40982068413 -50.4932266405 -1.09023136704 -9.41482068413 -50.4932266405 -1.09023136704 -9.41982068413 -50.4932266405 -1.09023136704 -9.42482068413 -50.4932266405 -1.09023136704 -9.42982068413 -50.4932266405 -1.09023136704 -9.43482068413 -50.4932266405 -1.09023136704 -9.43982068413 -50.4932266405 -1.09023136704 -9.44482068413 -50.4932266405 -1.09023136704 -9.44982068413 -50.4932266405 -1.09023136704 -9.45482068413 -50.4932266405 -1.09023136704 -9.45982068413 -50.4932266405 -1.09023136704 -9.46482068413 -50.4932266405 -1.09023136704 -9.46982068413 -50.4932266405 -1.09023136704 -9.47482068413 -50.4932266405 -1.09023136704 -9.47982068413 -50.4932266405 -1.09023136704 -9.48482068413 -50.4932266405 -1.09023136704 -9.48982068413 -50.4932266405 -1.09023136704 -9.49482068413 -50.4932266405 -1.09023136704 -9.49982068413 -50.4932266405 -1.09023136704 -9.50482068413 -50.4932266405 -1.09023136704 -9.50982068413 -50.4932266405 -1.09023136704 -9.51482068413 -50.4932266405 -1.09023136704 -9.51982068413 -50.4932266405 -1.09023136704 -9.52482068413 -50.4932266405 -1.09023136704 -9.52982068413 -50.4932266405 -1.09023136704 -9.53482068413 -50.4932266405 -1.09023136704 -9.53982068413 -50.4932266405 -1.09023136704 -9.54482068413 -50.4932266405 -1.09023136704 -9.54982068413 -50.4932266405 -1.09023136704 -9.55482068413 -50.4932266405 -1.09023136704 -9.55982068413 -50.4932266405 -1.09023136704 -9.56482068413 -50.4932266405 -1.09023136704 -9.56982068413 -50.4932266405 -1.09023136704 -9.57482068413 -50.4932266405 -1.09023136704 -9.57982068413 -50.4932266405 -1.09023136704 -9.58482068413 -50.4932266405 -1.09023136704 -9.58982068413 -50.4932266405 -1.09023136704 -9.59482068413 -50.4932266405 -1.09023136704 -9.59982068413 -50.4932266405 -1.09023136704 -9.60482068413 -50.4932266405 -1.09023136704 -9.60982068413 -50.4932266405 -1.09023136704 -9.61482068413 -50.4932266405 -1.09023136704 -9.61982068413 -50.4932266405 -1.09023136704 -9.62482068413 -50.4932266405 -1.09023136704 -9.62982068413 -50.4932266405 -1.09023136704 -9.63482068413 -50.4932266405 -1.09023136704 -9.63982068413 -50.4932266405 -1.09023136704 -9.64482068413 -50.4932266405 -1.09023136704 -9.64982068413 -50.4932266405 -1.09023136704 -9.65482068413 -50.4932266405 -1.09023136704 -9.65982068413 -50.4932266405 -1.09023136704 -9.66482068413 -50.4932266405 -1.09023136704 -9.66982068413 -50.4932266405 -1.09023136704 -9.67482068413 -50.4932266405 -1.09023136704 -9.67982068413 -50.4932266405 -1.09023136704 -9.68482068413 -50.4932266405 -1.09023136704 -9.68982068413 -50.4932266405 -1.09023136704 -9.69482068413 -50.4932266405 -1.09023136704 -9.69982068413 -50.4932266405 -1.09023136704 -9.70482068413 -50.4932266405 -1.09023136704 -9.70982068413 -50.4932266405 -1.09023136704 -9.71482068413 -50.4932266405 -1.09023136704 -9.71982068413 -50.4932266405 -1.09023136704 -9.72482068413 -50.4932266405 -1.09023136704 -9.72982068413 -50.4932266405 -1.09023136704 -9.73482068413 -50.4932266405 -1.09023136704 -9.73982068413 -50.4932266405 -1.09023136704 -9.74482068413 -50.4932266405 -1.09023136704 -9.74982068413 -50.4932266405 -1.09023136704 -9.75482068413 -50.4932266405 -1.09023136704 -9.75982068413 -50.4932266405 -1.09023136704 -9.76482068413 -50.4932266405 -1.09023136704 -9.76982068413 -50.4932266405 -1.09023136704 -9.77482068413 -50.4932266405 -1.09023136704 -9.77982068413 -50.4932266405 -1.09023136704 -9.78482068413 -50.4932266405 -1.09023136704 -9.78982068413 -50.4932266405 -1.09023136704 -9.79482068413 -50.4932266405 -1.09023136704 -9.79982068413 -50.4932266405 -1.09023136704 -9.80482068413 -50.4932266405 -1.09023136704 -9.80982068413 -50.4932266405 -1.09023136704 -9.81482068413 -50.4932266405 -1.09023136704 -9.81982068413 -50.4932266405 -1.09023136704 -9.82482068413 -50.4932266405 -1.09023136704 -9.82982068413 -50.4932266405 -1.09023136704 -9.83482068413 -50.4932266405 -1.09023136704 -9.83982068413 -50.4932266405 -1.09023136704 -9.84482068413 -50.4932266405 -1.09023136704 -9.84982068413 -50.4932266405 -1.09023136704 -9.85482068413 -50.4932266405 -1.09023136704 -9.85982068413 -50.4932266405 -1.09023136704 -9.86482068413 -50.4932266405 -1.09023136704 -9.86982068413 -50.4932266405 -1.09023136704 -9.87482068413 -50.4932266405 -1.09023136704 -9.87982068413 -50.4932266405 -1.09023136704 -9.88482068413 -50.4932266405 -1.09023136704 -9.88982068413 -50.4932266405 -1.09023136704 -9.89482068413 -50.4932266405 -1.09023136704 -9.89982068413 -50.4932266405 -1.09023136704 -9.90482068413 -50.4932266405 -1.09023136704 -9.90982068413 -50.4932266405 -1.09023136704 -9.91482068413 -50.4932266405 -1.09023136704 -9.91982068413 -50.4932266405 -1.09023136704 -9.92482068413 -50.4932266405 -1.09023136704 -9.92982068413 -50.4932266405 -1.09023136704 -9.93482068413 -50.4932266405 -1.09023136704 -9.93982068413 -50.4932266405 -1.09023136704 -9.94482068413 -50.4932266405 -1.09023136704 -9.94982068413 -50.4932266405 -1.09023136704 -9.95482068413 -50.4932266405 -1.09023136704 -9.95982068413 -50.4932266405 -1.09023136704 -9.96482068413 -50.4932266405 -1.09023136704 -9.96982068413 -50.4932266405 -1.09023136704 -9.97482068413 -50.4932266405 -1.09023136704 -9.97982068413 -50.4932266405 -1.09023136704 -9.98482068413 -50.4932266405 -1.09023136704 -9.98982068413 -50.4932266405 -1.09023136704 -9.99482068413 -50.4932266405 -1.09023136704 -9.99982068413 -50.4932266405 -1.09023136704 -10.0048206841 -50.4932266405 -1.09023136704 -10.0098206841 -50.4932266405 -1.09023136704 -10.0148206841 291.907740917 -1.09023136704 -10.0198206841 381.698543129 -1.09023136704 -10.0248206841 481.658449896 -1.09023136704 -10.0298206841 1173.98961508 -1.09023136704 -10.0348206841 1515.3604985 -1.09023136704 -10.0398206841 1993.62466976 -1.09023136704 -10.0448206841 2132.2409352 -1.09023136704 -10.0498206841 1924.8375966 -1.09023136704 -10.0548206841 1686.82791388 -1.09023136704 -10.0598206841 1067.3712092 -1.09023136704 -10.0648206841 860.194197517 -1.09023136704 -10.0698206841 609.630396583 -1.09023136704 -10.0748206841 468.010216718 -1.09023136704 -10.0798206841 396.978664775 -1.09023136704 -10.0848206841 378.452876289 -1.09023136704 -10.0898206841 378.264810676 -1.09023136704 -10.0948206841 393.887638567 -1.09023136704 -10.0998206841 426.379149591 -1.09023136704 -10.1048206841 465.13804213 -1.09023136704 -10.1098206841 483.403426585 -1.09023136704 -10.1148206841 514.178223135 -1.09023136704 -10.1198206841 523.052006284 -1.09023136704 -10.1248206841 529.563823382 -1.09023136704 -10.1298206841 540.60182448 3.92143304247 -10.1348206841 549.421345577 3.912887874 -10.1398206841 558.513535321 3.912887874 -10.1448206841 575.434290135 3.912887874 -10.1498206841 587.819082005 3.912887874 -10.1548206841 601.919219449 3.912887874 -10.1598206841 613.069270051 3.912887874 -10.1648206841 625.296343483 3.912887874 -10.1698206841 631.813789971 3.912887874 -10.1748206841 633.028703883 3.912887874 -10.1798206841 634.387873479 3.912887874 -10.1848206841 633.800774301 3.912887874 -10.1898206841 631.561978608 3.912887874 -10.1948206841 626.152263365 3.912887874 -10.1998206841 617.441160542 3.912887874 -10.2048206841 609.79456981 3.912887874 -10.2098206841 598.835103005 3.912887874 -10.2148206841 591.197450682 3.912887874 -10.2198206841 586.573784874 3.912887874 -10.2248206841 582.399464767 3.912887874 -10.2298206841 580.563837228 3.912887874 -10.2348206841 580.904597445 3.912887874 -10.2398206841 584.828458245 3.912887874 -10.2448206841 592.016978348 3.912887874 -10.2498206841 601.611750363 3.912887874 -10.2548206841 613.455706665 3.912887874 -10.2598206841 629.381737174 3.912887874 -10.2648206841 648.1160804 3.912887874 -10.2698206841 669.508455254 3.912887874 -10.2748206841 692.665798672 3.912887874 -10.2798206841 713.954147291 3.912887874 -10.2848206841 735.604302872 3.912887874 -10.2898206841 756.12741523 3.912887874 -10.2948206841 774.466450074 3.912887874 -10.2998206841 799.222357682 3.912887874 -10.3048206841 821.96951822 3.912887874 -10.3098206841 839.738471898 3.912887874 -10.3148206841 859.639760556 3.912887874 -10.3198206841 870.926709021 3.912887874 -10.3248206841 885.382894714 3.912887874 -10.3298206841 891.852300886 3.912887874 -10.3348206841 896.968415501 3.912887874 -10.3398206841 899.084929638 3.912887874 -10.3448206841 895.934905065 3.912887874 -10.3498206841 892.172908668 3.912887874 -10.3548206841 879.789377555 3.912887874 -10.3598206841 864.858698325 3.912887874 -10.3648206841 846.332317092 3.912887874 -10.3698206841 820.274173971 3.912887874 -10.3748206841 792.998801189 3.912887874 -10.3798206841 760.789183213 3.912887874 -10.3848206841 748.883180893 3.912887874 -10.3898206841 744.429042667 3.912887874 -10.3948206841 712.726310687 3.912887874 -10.3998206841 681.616194729 3.912887874 -10.4048206841 655.497188472 3.912887874 -10.4098206841 632.430984753 3.912887874 -10.4148206841 637.290676172 3.912887874 -10.4198206841 593.902397302 3.912887874 -10.4248206841 568.200075833 3.912887874 -10.4298206841 535.662138143 3.912887874 -10.4348206841 498.45510711 3.912887874 -10.4398206841 468.251739365 3.912887874 -10.4448206841 405.62616366 3.912887874 -10.4498206841 376.958492435 3.912887874 -10.4548206841 362.110577804 3.912887874 -10.4598206841 348.723943146 3.912887874 -10.4648206841 339.91771928 3.912887874 -10.4698206841 350.659038648 3.912887874 -10.4748206841 342.776664414 3.912887874 -10.4798206841 329.205622503 3.912887874 -10.4848206841 343.141761615 3.912887874 -10.4898206841 336.397874496 3.912887874 -10.4948206841 334.605988163 3.912887874 -10.4998206841 340.182842793 3.912887874 -10.5048206841 355.614783338 3.912887874 -10.5098206841 361.802973078 3.912887874 -10.5148206841 370.022508634 3.912887874 -10.5198206841 376.332438767 3.912887874 -10.5248206841 390.612782705 3.912887874 -10.5298206841 407.453521337 3.912887874 -10.5348206841 419.53116547 3.912887874 -10.5398206841 554.995540642 3.912887874 -10.5448206841 488.767313893 3.912887874 -10.5498206841 451.460079279 3.912887874 -10.5548206841 444.97560302 3.912887874 -10.5598206841 429.259040786 3.912887874 -10.5648206841 416.607478308 3.912887874 -10.5698206841 411.468623789 3.912887874 -10.5748206841 407.759927941 3.912887874 -10.5798206841 401.546194317 3.912887874 -10.5848206841 402.050669566 3.912887874 -10.5898206841 388.976855932 3.912887874 -10.5948206841 381.172802385 3.912887874 -10.5998206841 378.908023354 3.912887874 -10.6048206841 375.183475831 3.912887874 -10.6098206841 375.293248872 3.912887874 -10.6148206841 374.356423619 3.912887874 -10.6198206841 375.671125031 3.912887874 -10.6248206841 376.154879811 3.912887874 -10.6298206841 381.422598774 3.912887874 -10.6348206841 383.666766598 3.912887874 -10.6398206841 388.38086066 3.912887874 -10.6448206841 394.042050138 3.912887874 -10.6498206841 393.965318318 3.912887874 -10.6548206841 393.705288325 3.912887874 -10.6598206841 395.788150987 3.912887874 -10.6648206841 392.270087573 3.912887874 -10.6698206841 393.863528612 3.912887874 -10.6748206841 387.646357156 3.912887874 -10.6798206841 383.375925134 3.912887874 -10.6848206841 376.015290411 3.912887874 -10.6898206841 358.745150255 3.912887874 -10.6948206841 351.917456734 3.912887874 -10.6998206841 343.06979548 3.912887874 -10.7048206841 340.022466878 3.912887874 -10.7098206841 333.064584776 3.912887874 -10.7148206841 324.558475237 3.912887874 -10.7198206841 319.144380553 3.912887874 -10.7248206841 308.238564525 3.912887874 -10.7298206841 304.035206954 3.912887874 -10.7348206841 299.957880946 3.912887874 -10.7398206841 297.389176794 3.912887874 -10.7448206841 292.824371473 3.912887874 -10.7498206841 287.219732694 3.912887874 -10.7548206841 289.188245224 3.912887874 -10.7598206841 287.524477797 3.912887874 -10.7648206841 284.116199306 3.912887874 -10.7698206841 273.520062842 3.912887874 -10.7748206841 269.834818971 3.912887874 -10.7798206841 263.492077401 3.912887874 -10.7848206841 261.763822697 3.912887874 -10.7898206841 259.812974778 3.912887874 -10.7948206841 247.271513611 3.912887874 -10.7998206841 213.126899061 3.912887874 -10.8048206841 210.591312401 3.912887874 -10.8098206841 230.008151326 3.912887874 -10.8148206841 216.526585552 3.912887874 -10.8198206841 206.819993437 3.912887874 -10.8248206841 198.715112026 3.912887874 -10.8298206841 192.798585043 3.912887874 -10.8348206841 184.642162203 3.912887874 -10.8398206841 178.104436328 3.912887874 -10.8448206841 173.585835294 3.912887874 -10.8498206841 169.586057279 3.912887874 -10.8548206841 164.667510401 3.912887874 -10.8598206841 157.02598215 3.912887874 -10.8648206841 150.274024765 3.912887874 -10.8698206841 141.242963657 3.912887874 -10.8748206841 129.912120863 3.912887874 -10.8798206841 118.942839563 3.912887874 -10.8848206841 103.892162512 3.912887874 -10.8898206841 91.2709457563 3.912887874 -10.8948206841 80.8509647069 3.912887874 -10.8998206841 73.483346982 3.912887874 -10.9048206841 60.0590122727 3.912887874 -10.9098206841 47.5323218118 3.912887874 -10.9148206841 35.0771648706 3.912887874 -10.9198206841 23.3992787548 3.912887874 -10.9248206841 22.8319785602 3.912887874 -10.9298206841 9.72924222106 3.912887874 -10.9348206841 -19.82463382 3.912887874 -10.9398206841 -11.3748458111 3.912887874 -10.9448206841 -11.3748458111 3.912887874 -10.9498206841 -48.3817312855 3.912887874 -10.9548206841 -70.6368493735 3.912887874 -10.9598206841 -80.8969655484 3.912887874 -10.9648206841 -85.8283633063 3.912887874 -10.9698206841 -73.6853466366 3.912887874 -10.9748206841 -71.5289503879 3.912887874 -10.9798206841 -73.2543524301 3.912887874 -10.9848206841 -48.6569260734 3.912887874 -10.9898206841 -70.1115567287 3.912887874 -10.9948206841 -25.5246647678 3.912887874 -10.9998206841 -20.9876052105 3.912887874 -11.0048206841 -20.9876052105 3.912887874 -11.0098206841 -20.9876052105 3.912887874 -11.0148206841 -20.9876052105 3.912887874 -11.0198206841 -20.9876052105 3.912887874 -11.0248206841 -20.9876052105 3.912887874 -11.0298206841 -20.9876052105 3.912887874 -11.0348206841 -20.9876052105 3.912887874 -11.0398206841 -20.9876052105 3.912887874 -11.0448206841 -20.9876052105 3.912887874 -11.0498206841 -20.9876052105 3.912887874 -11.0548206841 -20.9876052105 3.912887874 -11.0598206841 -20.9876052105 3.912887874 -11.0648206841 -20.9876052105 3.912887874 -11.0698206841 -20.9876052105 3.912887874 -11.0748206841 -20.9876052105 3.912887874 -11.0798206841 -20.9876052105 3.912887874 -11.0848206841 -20.9876052105 3.912887874 -11.0898206841 -20.9876052105 3.912887874 -11.0948206841 -20.9876052105 3.912887874 -11.0998206841 -20.9876052105 3.912887874 -11.1048206841 -20.9876052105 3.912887874 -11.1098206841 -20.9876052105 3.912887874 -11.1148206841 -20.9876052105 3.912887874 -11.1198206841 -20.9876052105 3.912887874 -11.1248206841 -20.9876052105 3.912887874 -11.1298206841 -20.9876052105 3.912887874 -11.1348206841 -20.9876052105 3.912887874 -11.1398206841 -20.9876052105 3.912887874 -11.1448206841 -20.9876052105 3.912887874 -11.1498206841 -20.9876052105 3.912887874 -11.1548206841 -20.9876052105 3.912887874 -11.1598206841 -20.9876052105 3.912887874 -11.1648206841 -20.9876052105 3.912887874 -11.1698206841 -20.9876052105 3.912887874 -11.1748206841 -20.9876052105 3.912887874 -11.1798206841 -20.9876052105 3.912887874 -11.1848206841 -20.9876052105 3.912887874 -11.1898206841 -20.9876052105 3.912887874 -11.1948206841 -20.9876052105 3.912887874 -11.1998206841 -20.9876052105 3.912887874 -11.2048206841 -20.9876052105 3.912887874 -11.2098206841 -20.9876052105 3.912887874 -11.2148206841 -20.9876052105 3.912887874 -11.2198206841 -20.9876052105 3.912887874 -11.2248206841 -20.9876052105 3.912887874 -11.2298206841 -20.9876052105 3.912887874 -11.2348206841 -20.9876052105 3.912887874 -11.2398206841 -20.9876052105 3.912887874 -11.2448206841 -20.9876052105 3.912887874 -11.2498206841 -20.9876052105 3.912887874 -11.2548206841 -20.9876052105 3.912887874 -11.2598206841 -20.9876052105 3.912887874 -11.2648206841 -20.9876052105 3.912887874 -11.2698206841 -20.9876052105 3.912887874 -11.2748206841 -20.9876052105 3.912887874 -11.2798206841 -20.9876052105 3.912887874 -11.2848206841 -20.9876052105 3.912887874 -11.2898206841 -20.9876052105 3.912887874 -11.2948206841 -20.9876052105 3.912887874 -11.2998206841 -20.9876052105 3.912887874 -11.3048206841 -20.9876052105 3.912887874 -11.3098206841 -20.9876052105 3.912887874 -11.3148206841 -20.9876052105 3.912887874 -11.3198206841 -20.9876052105 3.912887874 -11.3248206841 -20.9876052105 3.912887874 -11.3298206841 -20.9876052105 3.912887874 -11.3348206841 -20.9876052105 3.912887874 -11.3398206841 -20.9876052105 3.912887874 -11.3448206841 -20.9876052105 3.912887874 -11.3498206841 -20.9876052105 3.912887874 -11.3548206841 -20.9876052105 3.912887874 -11.3598206841 -20.9876052105 3.912887874 -11.3648206841 -20.9876052105 3.912887874 -11.3698206841 -20.9876052105 3.912887874 -11.3748206841 -20.9876052105 3.912887874 -11.3798206841 -20.9876052105 3.912887874 -11.3848206841 -20.9876052105 3.912887874 -11.3898206841 -20.9876052105 3.912887874 -11.3948206841 -20.9876052105 3.912887874 -11.3998206841 -20.9876052105 3.912887874 -11.4048206841 -20.9876052105 3.912887874 -11.4098206841 -20.9876052105 3.912887874 -11.4148206841 -20.9876052105 3.912887874 -11.4198206841 -20.9876052105 3.912887874 -11.4248206841 -20.9876052105 3.912887874 -11.4298206841 -20.9876052105 3.912887874 -11.4348206841 -20.9876052105 3.912887874 -11.4398206841 -20.9876052105 3.912887874 -11.4448206841 -20.9876052105 3.912887874 -11.4498206841 -20.9876052105 3.912887874 -11.4548206841 -20.9876052105 3.912887874 -11.4598206841 -20.9876052105 3.912887874 -11.4648206841 -20.9876052105 3.912887874 -11.4698206841 -20.9876052105 3.912887874 -11.4748206841 -20.9876052105 3.912887874 -11.4798206841 -20.9876052105 3.912887874 -11.4848206841 -20.9876052105 3.912887874 -11.4898206841 -20.9876052105 3.912887874 -11.4948206841 -20.9876052105 3.912887874 -11.4998206841 -20.9876052105 3.912887874 -11.5048206841 -20.9876052105 3.912887874 -11.5098206841 -20.9876052105 3.912887874 -11.5148206841 -20.9876052105 3.912887874 -11.5198206841 -20.9876052105 3.912887874 -11.5248206841 -20.9876052105 3.912887874 -11.5298206841 -20.9876052105 3.912887874 -11.5348206841 -20.9876052105 3.912887874 -11.5398206841 -20.9876052105 3.912887874 -11.5448206841 -20.9876052105 3.912887874 -11.5498206841 -20.9876052105 3.912887874 -11.5548206841 -20.9876052105 3.912887874 -11.5598206841 -20.9876052105 3.912887874 -11.5648206841 -20.9876052105 3.912887874 -11.5698206841 -20.9876052105 3.912887874 -11.5748206841 -20.9876052105 3.912887874 -11.5798206841 -20.9876052105 3.912887874 -11.5848206841 -20.9876052105 3.912887874 -11.5898206841 -20.9876052105 3.912887874 -11.5948206841 -20.9876052105 3.912887874 -11.5998206841 -20.9876052105 3.912887874 -11.6048206841 -20.9876052105 3.912887874 -11.6098206841 -20.9876052105 3.912887874 -11.6148206841 -20.9876052105 3.912887874 -11.6198206841 -20.9876052105 3.912887874 -11.6248206841 -20.9876052105 3.912887874 -11.6298206841 -20.9876052105 3.912887874 -11.6348206841 -20.9876052105 3.912887874 -11.6398206841 -20.9876052105 3.912887874 -11.6448206841 -20.9876052105 3.912887874 -11.6498206841 -20.9876052105 3.912887874 -11.6548206841 -20.9876052105 3.912887874 -11.6598206841 -20.9876052105 3.912887874 -11.6648206841 -20.9876052105 3.912887874 -11.6698206841 -20.9876052105 3.912887874 -11.6748206841 -20.9876052105 3.912887874 -11.6798206841 -20.9876052105 3.912887874 -11.6848206841 -20.9876052105 3.912887874 -11.6898206841 -20.9876052105 3.912887874 -11.6948206841 -20.9876052105 3.912887874 -11.6998206841 -20.9876052105 3.912887874 -11.7048206841 -20.9876052105 3.912887874 -11.7098206841 -20.9876052105 3.912887874 -11.7148206841 -20.9876052105 3.912887874 -11.7198206841 -20.9876052105 3.912887874 -11.7248206841 -20.9876052105 3.912887874 -11.7298206841 -20.9876052105 3.912887874 -11.7348206841 -20.9876052105 3.912887874 -11.7398206841 -20.9876052105 3.912887874 -11.7448206841 -20.9876052105 3.912887874 -11.7498206841 -20.9876052105 3.912887874 -11.7548206841 -20.9876052105 3.912887874 -11.7598206841 -20.9876052105 3.912887874 -11.7648206841 -20.9876052105 3.912887874 -11.7698206841 -20.9876052105 3.912887874 -11.7748206841 -20.9876052105 3.912887874 -11.7798206841 -20.9876052105 3.912887874 -11.7848206841 -20.9876052105 3.912887874 -11.7898206841 -20.9876052105 3.912887874 -11.7948206841 -20.9876052105 3.912887874 -11.7998206841 -20.9876052105 3.912887874 -11.8048206841 -20.9876052105 3.912887874 -11.8098206841 -20.9876052105 3.912887874 -11.8148206841 -20.9876052105 3.912887874 -11.8198206841 -20.9876052105 3.912887874 -11.8248206841 -20.9876052105 3.912887874 -11.8298206841 -20.9876052105 3.912887874 -11.8348206841 -20.9876052105 3.912887874 -11.8398206841 -20.9876052105 3.912887874 -11.8448206841 -20.9876052105 3.912887874 -11.8498206841 -20.9876052105 3.912887874 -11.8548206841 -20.9876052105 3.912887874 -11.8598206841 -20.9876052105 3.912887874 -11.8648206841 -20.9876052105 3.912887874 -11.8698206841 -20.9876052105 3.912887874 -11.8748206841 -20.9876052105 3.912887874 -11.8798206841 -20.9876052105 3.912887874 -11.8848206841 -20.9876052105 3.912887874 -11.8898206841 -20.9876052105 3.912887874 -11.8948206841 -20.9876052105 3.912887874 -11.8998206841 -20.9876052105 3.912887874 -11.9048206841 -20.9876052105 3.912887874 -11.9098206841 -20.9876052105 3.912887874 -11.9148206841 -20.9876052105 3.912887874 -11.9198206841 464.737889177 3.912887874 -11.9248206841 1146.20942818 3.912887874 -11.9298206841 1198.99469728 3.912887874 -11.9348206841 1350.76603559 3.912887874 -11.9398206841 1447.54526823 3.912887874 -11.9448206841 1496.12880707 3.912887874 -11.9498206841 1572.58068141 3.912887874 -11.9548206841 1243.44768804 3.912887874 -11.9598206841 969.736005916 3.912887874 -11.9648206841 811.12510228 3.912887874 -11.9698206841 624.129905476 3.912887874 -11.9748206841 512.74813669 3.912887874 -11.9798206841 467.710065431 3.912887874 -11.9848206841 480.380294984 3.912887874 -11.9898206841 492.830954314 3.912887874 -11.9948206841 512.796865151 3.912887874 -11.9998206841 527.457512834 3.912887874 -12.0048206841 541.979896173 3.912887874 -12.0098206841 552.424481886 3.912887874 -12.0148206841 553.56842632 3.912887874 -12.0198206841 549.893860797 3.912887874 -12.0248206841 557.156363226 3.912887874 -12.0298206841 553.816947753 3.912887874 -12.0348206841 561.28608289 3.912887874 -12.0398206841 562.593740541 3.912887874 -12.0448206841 569.17082739 3.912887874 -12.0498206841 571.603399307 3.912887874 -12.0548206841 575.957743576 3.912887874 -12.0598206841 579.719932697 3.912887874 -12.0648206841 582.186281548 3.912887874 -12.0698206841 581.349705289 3.912887874 -12.0748206841 580.064924228 3.912887874 -12.0798206841 576.640128732 3.912887874 -12.0848206841 573.509585905 3.912887874 -12.0898206841 566.406961638 3.912887874 -12.0948206841 556.57648873 3.912887874 -12.0998206841 549.383299066 3.912887874 -12.1048206841 542.991888555 3.912887874 -12.1098206841 539.558030578 3.912887874 -12.1148206841 535.127965626 3.912887874 -12.1198206841 532.675053767 3.912887874 -12.1248206841 531.945082891 3.912887874 -12.1298206841 530.788647615 3.912887874 -12.1348206841 543.215629911 3.912887874 -12.1398206841 546.345687125 3.912887874 -12.1448206841 553.761022346 3.912887874 -12.1498206841 567.031399478 3.912887874 -12.1548206841 581.247050053 3.912887874 -12.1598206841 597.665728285 3.912887874 -12.1648206841 613.448618614 3.912887874 -12.1698206841 624.491037644 3.912887874 -12.1748206841 650.732215766 3.912887874 -12.1798206841 666.21548424 3.912887874 -12.1848206841 682.752109667 3.912887874 -12.1898206841 699.419988693 3.912887874 -12.1948206841 718.965132517 3.912887874 -12.1998206841 738.777931975 3.912887874 -12.2048206841 753.707364867 3.912887874 -12.2098206841 771.337943706 3.912887874 -12.2148206841 782.2174347 3.912887874 -12.2198206841 797.160975657 3.912887874 -12.2248206841 816.857916583 3.912887874 -12.2298206841 826.978374254 3.912887874 -12.2348206841 843.281774469 3.912887874 -12.2398206841 853.550044627 3.912887874 -12.2448206841 883.691612937 3.912887874 -12.2498206841 901.226735125 3.912887874 -12.2548206841 884.778076902 3.912887874 -12.2598206841 899.278736682 3.912887874 -12.2648206841 914.404931312 3.912887874 -12.2698206841 921.477203499 3.912887874 -12.2748206841 886.872672792 3.912887874 -12.2798206841 892.031803206 3.912887874 -12.2848206841 859.449197056 3.912887874 -12.2898206841 879.624218527 3.912887874 -12.2948206841 848.765898848 3.912887874 -12.2998206841 807.915157727 3.912887874 -12.3048206841 757.534591488 3.912887874 -12.3098206841 707.68838884 3.912887874 -12.3148206841 675.5668643 3.912887874 -12.3198206841 643.209416787 3.912887874 -12.3248206841 616.477378523 3.912887874 -12.3298206841 594.296646966 3.912887874 -12.3348206841 563.116233018 3.912887874 -12.3398206841 548.511441185 3.912887874 -12.3448206841 523.015974477 3.912887874 -12.3498206841 507.8715047 3.912887874 -12.3548206841 490.246394078 3.912887874 -12.3598206841 465.585492869 3.912887874 -12.3648206841 437.046527115 3.912887874 -12.3698206841 410.872438095 3.912887874 -12.3748206841 403.00223141 3.912887874 -12.3798206841 395.849455376 3.912887874 -12.3848206841 388.017294232 3.912887874 -12.3898206841 393.261739842 3.912887874 -12.3948206841 398.899043519 3.912887874 -12.3998206841 399.300560756 3.912887874 -12.4048206841 401.927350993 3.912887874 -12.4098206841 396.121592743 3.912887874 -12.4148206841 393.822137297 3.912887874 -12.4198206841 391.907942118 3.912887874 -12.4248206841 391.760537393 3.912887874 -12.4298206841 395.279379222 3.912887874 -12.4348206841 405.717717821 3.912887874 -12.4398206841 415.248551575 3.912887874 -12.4448206841 423.174252806 3.912887874 -12.4498206841 428.803692665 3.912887874 -12.4548206841 435.336796396 3.912887874 -12.4598206841 443.743090507 3.912887874 -12.4648206841 433.604436111 3.912887874 -12.4698206841 429.240181122 3.912887874 -12.4748206841 418.977747152 3.912887874 -12.4798206841 406.616759554 3.912887874 -12.4848206841 394.873354725 3.912887874 -12.4898206841 387.784902122 3.912887874 -12.4948206841 383.916367033 3.912887874 -12.4998206841 380.356198321 3.912887874 -12.5048206841 374.953099722 3.912887874 -12.5098206841 374.858735317 3.912887874 -12.5148206841 372.196982134 3.912887874 -12.5198206841 366.023680269 3.912887874 -12.5248206841 366.661118995 3.912887874 -12.5298206841 360.433351706 3.912887874 -12.5348206841 358.691826834 3.912887874 -12.5398206841 357.585110549 3.912887874 -12.5448206841 356.268505867 3.912887874 -12.5498206841 357.66476615 3.912887874 -12.5548206841 363.055376085 3.912887874 -12.5598206841 360.759811274 3.912887874 -12.5648206841 367.736089201 3.912887874 -12.5698206841 365.36400804 3.912887874 -12.5748206841 363.736282468 3.912887874 -12.5798206841 359.189730925 3.912887874 -12.5848206841 354.42438795 3.912887874 -12.5898206841 352.880195785 3.912887874 -12.5948206841 351.202758807 3.912887874 -12.5998206841 352.00669432 3.912887874 -12.6048206841 349.145676014 3.912887874 -12.6098206841 349.563545286 3.912887874 -12.6148206841 340.934702601 3.912887874 -12.6198206841 331.946206982 3.912887874 -12.6248206841 328.853216987 3.912887874 -12.6298206841 321.490283975 3.912887874 -12.6348206841 315.399380438 3.912887874 -12.6398206841 310.069210572 3.912887874 -12.6448206841 304.808258068 3.912887874 -12.6498206841 296.376893592 3.912887874 -12.6548206841 288.657534777 3.912887874 -12.6598206841 280.057603278 3.912887874 -12.6648206841 276.65719921 3.912887874 -12.6698206841 272.682000132 3.912887874 -12.6748206841 269.668220451 3.912887874 -12.6798206841 267.483903291 3.912887874 -12.6848206841 263.12244645 3.912887874 -12.6898206841 259.624970362 3.912887874 -12.6948206841 256.861786488 3.912887874 -12.6998206841 250.434945069 3.912887874 -12.7048206841 246.890875316 3.912887874 -12.7098206841 242.099415138 3.912887874 -12.7148206841 238.548605701 3.912887874 -12.7198206841 232.769554642 3.912887874 -12.7248206841 229.581649938 3.912887874 -12.7298206841 223.434339261 3.912887874 -12.7348206841 215.097558014 3.912887874 -12.7398206841 203.857139699 3.912887874 -12.7448206841 196.42080625 3.912887874 -12.7498206841 185.747599372 3.912887874 -12.7548206841 176.840729914 3.912887874 -12.7598206841 168.657934291 3.912887874 -12.7648206841 158.982900603 3.912887874 -12.7698206841 158.982900603 3.912887874 -12.7748206841 149.870105928 3.912887874 -12.7798206841 141.67916548 3.912887874 -12.7848206841 126.277754197 3.912887874 -12.7898206841 107.304899936 3.912887874 -12.7948206841 96.6693381761 3.912887874 -12.7998206841 87.519145486 3.912887874 -12.8048206841 78.0246160378 3.912887874 -12.8098206841 71.8636329289 3.912887874 -12.8148206841 69.9414615267 3.912887874 -12.8198206841 65.089313674 3.912887874 -12.8248206841 56.9833696594 3.912887874 -12.8298206841 48.120052182 3.912887874 -12.8348206841 34.2227336537 3.912887874 -12.8398206841 16.8079292681 3.912887874 -12.8448206841 6.73579479872 3.912887874 -12.8498206841 -12.1387742363 3.912887874 -12.8548206841 -29.9758952382 3.912887874 -12.8598206841 -47.6285471807 3.912887874 -12.8648206841 -62.7508259412 3.912887874 -12.8698206841 -70.0939005484 3.912887874 -12.8748206841 -73.0451843455 3.912887874 -12.8798206841 -73.0451843455 3.912887874 -12.8848206841 -73.0451843455 3.912887874 -12.8898206841 -73.0451843455 3.912887874 -12.8948206841 -73.0451843455 3.912887874 -12.8998206841 -73.0451843455 3.912887874 -12.9048206841 -73.0451843455 3.912887874 -12.9098206841 -73.0451843455 3.912887874 -12.9148206841 -73.0451843455 3.912887874 -12.9198206841 -73.0451843455 3.912887874 -12.9248206841 -73.0451843455 3.912887874 -12.9298206841 -73.0451843455 3.912887874 -12.9348206841 -73.0451843455 3.912887874 -12.9398206841 -73.0451843455 3.912887874 -12.9448206841 -73.0451843455 3.912887874 -12.9498206841 -73.0451843455 3.912887874 -12.9548206841 -73.0451843455 3.912887874 -12.9598206841 -73.0451843455 3.912887874 -12.9648206841 -73.0451843455 3.912887874 -12.9698206841 -73.0451843455 3.912887874 -12.9748206841 -73.0451843455 3.912887874 -12.9798206841 -73.0451843455 3.912887874 -12.9848206841 -73.0451843455 3.912887874 -12.9898206841 -73.0451843455 3.912887874 -12.9948206841 -73.0451843455 3.912887874 -12.9998206841 -73.0451843455 3.912887874 -13.0048206841 -73.0451843455 3.912887874 -13.0098206841 -73.0451843455 3.912887874 -13.0148206841 -73.0451843455 3.912887874 -13.0198206841 -73.0451843455 3.912887874 -13.0248206841 -73.0451843455 3.912887874 -13.0298206841 -73.0451843455 3.912887874 -13.0348206841 -73.0451843455 3.912887874 -13.0398206841 -73.0451843455 3.912887874 -13.0448206841 -73.0451843455 3.912887874 -13.0498206841 -73.0451843455 3.912887874 -13.0548206841 -73.0451843455 3.912887874 -13.0598206841 -73.0451843455 3.912887874 -13.0648206841 -73.0451843455 3.912887874 -13.0698206841 -73.0451843455 3.912887874 -13.0748206841 -73.0451843455 3.912887874 -13.0798206841 -73.0451843455 3.912887874 -13.0848206841 -73.0451843455 3.912887874 -13.0898206841 -73.0451843455 3.912887874 -13.0948206841 -73.0451843455 3.912887874 -13.0998206841 -73.0451843455 3.912887874 -13.1048206841 -73.0451843455 3.912887874 -13.1098206841 -73.0451843455 3.912887874 -13.1148206841 -73.0451843455 3.912887874 -13.1198206841 -73.0451843455 3.912887874 -13.1248206841 -73.0451843455 3.912887874 -13.1298206841 -73.0451843455 3.912887874 -13.1348206841 -73.0451843455 3.912887874 -13.1398206841 -73.0451843455 3.912887874 -13.1448206841 -73.0451843455 3.912887874 -13.1498206841 -73.0451843455 3.912887874 -13.1548206841 -73.0451843455 3.912887874 -13.1598206841 -73.0451843455 3.912887874 -13.1648206841 -73.0451843455 3.912887874 -13.1698206841 -73.0451843455 3.912887874 -13.1748206841 -73.0451843455 3.912887874 -13.1798206841 -73.0451843455 3.912887874 -13.1848206841 -73.0451843455 3.912887874 -13.1898206841 -73.0451843455 3.912887874 -13.1948206841 -73.0451843455 3.912887874 -13.1998206841 -73.0451843455 3.912887874 -13.2048206841 -73.0451843455 3.912887874 -13.2098206841 -73.0451843455 3.912887874 -13.2148206841 -73.0451843455 3.912887874 -13.2198206841 -73.0451843455 3.912887874 -13.2248206841 -73.0451843455 3.912887874 -13.2298206841 -73.0451843455 3.912887874 -13.2348206841 -73.0451843455 3.912887874 -13.2398206841 -73.0451843455 3.912887874 -13.2448206841 -73.0451843455 3.912887874 -13.2498206841 -73.0451843455 3.912887874 -13.2548206841 -73.0451843455 3.912887874 -13.2598206841 -73.0451843455 3.912887874 -13.2648206841 -73.0451843455 3.912887874 -13.2698206841 -73.0451843455 3.912887874 -13.2748206841 -73.0451843455 3.912887874 -13.2798206841 -73.0451843455 3.912887874 -13.2848206841 -73.0451843455 3.912887874 -13.2898206841 -73.0451843455 3.912887874 -13.2948206841 -73.0451843455 3.912887874 -13.2998206841 -73.0451843455 3.912887874 -13.3048206841 -73.0451843455 3.912887874 -13.3098206841 -73.0451843455 3.912887874 -13.3148206841 -73.0451843455 3.912887874 -13.3198206841 -73.0451843455 3.912887874 -13.3248206841 -73.0451843455 3.912887874 -13.3298206841 -73.0451843455 3.912887874 -13.3348206841 -73.0451843455 3.912887874 -13.3398206841 -73.0451843455 3.912887874 -13.3448206841 -73.0451843455 3.912887874 -13.3498206841 -73.0451843455 3.912887874 -13.3548206841 -73.0451843455 3.912887874 -13.3598206841 -73.0451843455 3.912887874 -13.3648206841 -73.0451843455 3.912887874 -13.3698206841 -73.0451843455 3.912887874 -13.3748206841 -73.0451843455 3.912887874 -13.3798206841 -73.0451843455 3.912887874 -13.3848206841 -73.0451843455 3.912887874 -13.3898206841 -73.0451843455 3.912887874 -13.3948206841 -73.0451843455 3.912887874 -13.3998206841 -73.0451843455 3.912887874 -13.4048206841 -73.0451843455 3.912887874 -13.4098206841 -73.0451843455 3.912887874 -13.4148206841 -73.0451843455 3.912887874 -13.4198206841 -73.0451843455 3.912887874 -13.4248206841 -73.0451843455 3.912887874 -13.4298206841 -73.0451843455 3.912887874 -13.4348206841 -73.0451843455 3.912887874 -13.4398206841 -73.0451843455 3.912887874 -13.4448206841 -73.0451843455 3.912887874 -13.4498206841 -73.0451843455 3.912887874 -13.4548206841 -73.0451843455 3.912887874 -13.4598206841 -73.0451843455 3.912887874 -13.4648206841 -73.0451843455 3.912887874 -13.4698206841 -73.0451843455 3.912887874 -13.4748206841 -73.0451843455 3.912887874 -13.4798206841 -73.0451843455 3.912887874 -13.4848206841 -73.0451843455 3.912887874 -13.4898206841 -73.0451843455 3.912887874 -13.4948206841 -73.0451843455 3.912887874 -13.4998206841 -73.0451843455 3.912887874 -13.5048206841 -73.0451843455 3.912887874 -13.5098206841 -73.0451843455 3.912887874 -13.5148206841 -73.0451843455 3.912887874 -13.5198206841 -73.0451843455 3.912887874 -13.5248206841 -73.0451843455 3.912887874 -13.5298206841 -73.0451843455 3.912887874 -13.5348206841 -73.0451843455 3.912887874 -13.5398206841 -73.0451843455 3.912887874 -13.5448206841 -73.0451843455 3.912887874 -13.5498206841 -73.0451843455 3.912887874 -13.5548206841 -73.0451843455 3.912887874 -13.5598206841 -73.0451843455 3.912887874 -13.5648206841 -73.0451843455 3.912887874 -13.5698206841 -73.0451843455 3.912887874 -13.5748206841 -73.0451843455 3.912887874 -13.5798206841 -73.0451843455 3.912887874 -13.5848206841 -73.0451843455 3.912887874 -13.5898206841 -73.0451843455 3.912887874 -13.5948206841 -73.0451843455 3.912887874 -13.5998206841 -73.0451843455 3.912887874 -13.6048206841 -73.0451843455 3.912887874 -13.6098206841 -73.0451843455 3.912887874 -13.6148206841 -73.0451843455 3.912887874 -13.6198206841 -73.0451843455 3.912887874 -13.6248206841 -73.0451843455 3.912887874 -13.6298206841 -73.0451843455 3.912887874 -13.6348206841 -73.0451843455 3.912887874 -13.6398206841 -73.0451843455 3.912887874 -13.6448206841 -73.0451843455 3.912887874 -13.6498206841 -73.0451843455 3.912887874 -13.6548206841 -73.0451843455 3.912887874 -13.6598206841 -73.0451843455 3.912887874 -13.6648206841 -73.0451843455 3.912887874 -13.6698206841 -73.0451843455 3.912887874 -13.6748206841 -73.0451843455 3.912887874 -13.6798206841 -73.0451843455 3.912887874 -13.6848206841 -73.0451843455 3.912887874 -13.6898206841 -73.0451843455 3.912887874 -13.6948206841 -73.0451843455 3.912887874 -13.6998206841 -73.0451843455 3.912887874 -13.7048206841 -73.0451843455 3.912887874 -13.7098206841 -73.0451843455 3.912887874 -13.7148206841 -73.0451843455 3.912887874 -13.7198206841 -73.0451843455 3.912887874 -13.7248206841 -73.0451843455 3.912887874 -13.7298206841 -73.0451843455 3.912887874 -13.7348206841 -73.0451843455 3.912887874 -13.7398206841 -73.0451843455 3.912887874 -13.7448206841 -73.0451843455 3.912887874 -13.7498206841 -73.0451843455 3.912887874 -13.7548206841 -73.0451843455 3.912887874 -13.7598206841 -73.0451843455 3.912887874 -13.7648206841 -73.0451843455 3.912887874 -13.7698206841 -73.0451843455 3.912887874 -13.7748206841 -73.0451843455 3.912887874 -13.7798206841 -73.0451843455 3.912887874 -13.7848206841 -73.0451843455 3.912887874 -13.7898206841 -73.0451843455 3.912887874 -13.7948206841 -73.0451843455 3.912887874 -13.7998206841 -73.0451843455 3.912887874 -13.8048206841 -73.0451843455 3.912887874 -13.8098206841 -73.0451843455 3.912887874 -13.8148206841 -73.0451843455 3.912887874 -13.8198206841 -73.0451843455 3.912887874 -13.8248206841 -73.0451843455 3.912887874 -13.8298206841 -73.0451843455 3.912887874 -13.8348206841 875.48306836 3.912887874 -13.8398206841 1231.61667783 3.912887874 -13.8448206841 1338.98376269 3.912887874 -13.8498206841 1465.59646288 3.912887874 -13.8548206841 1441.45835286 3.912887874 -13.8598206841 1517.09722775 3.912887874 -13.8648206841 1400.25564503 3.912887874 -13.8698206841 1245.00255756 3.912887874 -13.8748206841 1069.47056126 3.912887874 -13.8798206841 956.523372381 3.912887874 -13.8848206841 830.716508498 3.912887874 -13.8898206841 674.924173278 3.912887874 -13.8948206841 613.944788728 3.912887874 -13.8998206841 529.268664875 3.912887874 -13.9048206841 469.846238165 3.912887874 -13.9098206841 409.67176799 3.912887874 -13.9148206841 411.470642963 3.912887874 -13.9198206841 398.052824694 3.912887874 -13.9248206841 410.419538467 3.912887874 -13.9298206841 438.093864542 3.912887874 -13.9348206841 468.644124138 3.912887874 -13.9398206841 503.073508626 3.912887874 -13.9448206841 531.161084863 3.912887874 -13.9498206841 556.326252104 3.912887874 -13.9548206841 581.198976803 3.912887874 -13.9598206841 595.854453036 3.912887874 -13.9648206841 607.336172542 3.912887874 -13.9698206841 611.856536586 3.912887874 -13.9748206841 610.872536141 3.912887874 -13.9798206841 610.60611013 3.912887874 -13.9848206841 603.411859247 3.912887874 -13.9898206841 596.176046913 3.912887874 -13.9948206841 587.630757851 3.912887874 -13.9998206841 583.890255195 3.912887874 -14.0048206841 575.63066231 3.912887874 -14.0098206841 569.459307487 3.912887874 -14.0148206841 568.322842785 3.912887874 -14.0198206841 572.667729637 3.912887874 -14.0248206841 573.685697665 3.912887874 -14.0298206841 578.620753002 3.912887874 -14.0348206841 580.949914521 3.912887874 -14.0398206841 582.982157577 3.912887874 -14.0448206841 589.399506096 3.912887874 -14.0498206841 594.444153923 3.912887874 -14.0548206841 598.997902 3.912887874 -14.0598206841 607.89387867 3.912887874 -14.0648206841 614.206525453 3.912887874 -14.0698206841 624.571286067 3.912887874 -14.0748206841 634.927679654 3.912887874 -14.0798206841 643.262204714 3.912887874 -14.0848206841 655.830410497 3.912887874 -14.0898206841 665.072442887 3.912887874 -14.0948206841 679.908040442 3.912887874 -14.0998206841 694.177600304 3.912887874 -14.1048206841 704.763264539 3.912887874 -14.1098206841 686.290789138 3.912887874 -14.1148206841 727.237084136 3.912887874 -14.1198206841 737.67890897 3.912887874 -14.1248206841 756.158073365 3.912887874 -14.1298206841 771.712933809 3.912887874 -14.1348206841 800.660911691 3.912887874 -14.1398206841 826.556920228 3.912887874 -14.1448206841 842.81270383 3.912887874 -14.1498206841 867.744140561 3.912887874 -14.1548206841 895.442374933 3.912887874 -14.1598206841 862.212454378 3.912887874 -14.1648206841 890.141906842 3.912887874 -14.1698206841 876.751083297 3.912887874 -14.1748206841 856.680859524 3.912887874 -14.1798206841 842.803313825 3.912887874 -14.1848206841 816.150297568 3.912887874 -14.1898206841 822.911584722 3.912887874 -14.1948206841 788.497065618 3.912887874 -14.1998206841 756.878943827 3.912887874 -14.2048206841 732.141810534 3.912887874 -14.2098206841 681.380374055 3.912887874 -14.2148206841 649.492900979 3.912887874 -14.2198206841 610.410764029 3.912887874 -14.2248206841 576.874590725 3.912887874 -14.2298206841 539.600099529 3.912887874 -14.2348206841 526.465122803 3.912887874 -14.2398206841 512.391327945 3.912887874 -14.2448206841 503.474854922 3.912887874 -14.2498206841 473.682979935 3.912887874 -14.2548206841 422.232648308 3.912887874 -14.2598206841 424.673020781 3.912887874 -14.2648206841 426.199399881 3.912887874 -14.2698206841 420.920375028 3.912887874 -14.2748206841 414.301071989 3.912887874 -14.2798206841 416.136769129 3.912887874 -14.2848206841 402.57537572 3.912887874 -14.2898206841 399.341832806 3.912887874 -14.2948206841 394.48951637 3.912887874 -14.2998206841 386.041157894 3.912887874 -14.3048206841 375.618752748 3.912887874 -14.3098206841 383.538256713 3.912887874 -14.3148206841 382.744897018 3.912887874 -14.3198206841 376.955014292 3.912887874 -14.3248206841 372.733735874 3.912887874 -14.3298206841 367.657271006 3.912887874 -14.3348206841 365.72271327 3.912887874 -14.3398206841 377.212933145 3.912887874 -14.3448206841 384.377513372 3.912887874 -14.3498206841 388.076594012 3.912887874 -14.3548206841 396.012151998 3.912887874 -14.3598206841 402.972435256 3.912887874 -14.3648206841 412.24724007 3.912887874 -14.3698206841 418.803148907 3.912887874 -14.3748206841 427.939555968 3.912887874 -14.3798206841 424.071680579 3.912887874 -14.3848206841 434.044462238 3.912887874 -14.3898206841 431.050641474 3.912887874 -14.3948206841 430.739180969 3.912887874 -14.3998206841 424.882419736 3.912887874 -14.4048206841 413.618488405 3.912887874 -14.4098206841 413.618488405 3.912887874 -14.4148206841 403.84354451 3.912887874 -14.4198206841 384.371172928 3.912887874 -14.4248206841 369.637001366 3.912887874 -14.4298206841 361.213355911 3.912887874 -14.4348206841 353.893193268 3.912887874 -14.4398206841 345.063506481 3.912887874 -14.4448206841 339.180901228 3.912887874 -14.4498206841 337.495458585 3.912887874 -14.4548206841 332.615254175 3.912887874 -14.4598206841 335.159248358 3.912887874 -14.4648206841 338.024916183 3.912887874 -14.4698206841 339.267577181 3.912887874 -14.4748206841 340.936988865 3.912887874 -14.4798206841 343.818520008 3.912887874 -14.4848206841 349.46943906 3.912887874 -14.4898206841 355.637403677 3.912887874 -14.4948206841 354.866632897 3.912887874 -14.4998206841 351.50280063 3.912887874 -14.5048206841 347.812967042 3.912887874 -14.5098206841 343.472557564 3.912887874 -14.5148206841 342.936803117 3.912887874 -14.5198206841 337.633508718 3.912887874 -14.5248206841 326.26607288 3.912887874 -14.5298206841 317.594061658 3.912887874 -14.5348206841 310.95895985 3.912887874 -14.5398206841 305.472332265 3.912887874 -14.5448206841 291.407821835 3.912887874 -14.5498206841 286.424894833 3.912887874 -14.5548206841 279.793456082 3.912887874 -14.5598206841 272.473647711 3.912887874 -14.5648206841 266.571718576 3.912887874 -14.5698206841 261.315577537 3.912887874 -14.5748206841 250.934015884 3.912887874 -14.5798206841 242.36208467 3.912887874 -14.5848206841 232.339713775 3.912887874 -14.5898206841 223.536742852 3.912887874 -14.5948206841 227.93579004 3.912887874 -14.5998206841 218.871052554 3.912887874 -14.6048206841 215.490228075 3.912887874 -14.6098206841 212.230795937 3.912887874 -14.6148206841 207.725102078 3.912887874 -14.6198206841 207.27852084 3.912887874 -14.6248206841 201.64945155 3.912887874 -14.6298206841 195.013495035 3.912887874 -14.6348206841 196.1434797 3.912887874 -14.6398206841 185.43718115 3.912887874 -14.6448206841 177.434561054 3.912887874 -14.6498206841 169.254097559 3.912887874 -14.6548206841 159.711778424 3.912887874 -14.6598206841 150.532867308 3.912887874 -14.6648206841 132.412679197 3.912887874 -14.6698206841 122.00802363 3.912887874 -14.6748206841 114.589722562 3.912887874 -14.6798206841 109.763765543 3.912887874 -14.6848206841 105.032538029 3.912887874 -14.6898206841 96.0197875389 3.912887874 -14.6948206841 88.6424294061 3.912887874 -14.6998206841 78.156807677 3.912887874 -14.7048206841 67.7026645494 3.912887874 -14.7098206841 57.6485816356 3.912887874 -14.7148206841 50.1890121171 3.912887874 -14.7198206841 42.1862167769 3.912887874 -14.7248206841 33.4126551067 3.912887874 -14.7298206841 24.1974771797 3.912887874 -14.7348206841 17.8444598428 3.912887874 -14.7398206841 -11.0655562748 3.912887874 -14.7448206841 -23.4652576239 3.912887874 -14.7498206841 -26.164560673 3.912887874 -14.7548206841 -27.3505495491 3.912887874 -14.7598206841 -37.2682052026 3.912887874 -14.7648206841 -46.1808602065 3.912887874 -14.7698206841 -57.5053853015 3.912887874 -14.7748206841 -89.4845837792 3.912887874 -14.7798206841 -89.4845837792 3.912887874 -14.7848206841 -89.4845837792 3.912887874 -14.7898206841 -89.4845837792 3.912887874 -14.7948206841 -89.4845837792 3.912887874 -14.7998206841 -89.4845837792 3.912887874 -14.8048206841 -89.4845837792 3.912887874 -14.8098206841 -89.4845837792 3.912887874 -14.8148206841 -89.4845837792 3.912887874 -14.8198206841 -89.4845837792 3.912887874 -14.8248206841 -89.4845837792 3.912887874 -14.8298206841 -89.4845837792 3.912887874 -14.8348206841 -89.4845837792 3.912887874 -14.8398206841 -89.4845837792 3.912887874 -14.8448206841 -89.4845837792 3.912887874 -14.8498206841 -89.4845837792 3.912887874 -14.8548206841 -89.4845837792 3.912887874 -14.8598206841 -89.4845837792 3.912887874 -14.8648206841 -89.4845837792 3.912887874 -14.8698206841 -89.4845837792 3.912887874 -14.8748206841 -89.4845837792 3.912887874 -14.8798206841 -89.4845837792 3.912887874 -14.8848206841 -89.4845837792 3.912887874 -14.8898206841 -89.4845837792 3.912887874 -14.8948206841 -89.4845837792 3.912887874 -14.8998206841 -89.4845837792 3.912887874 -14.9048206841 -89.4845837792 3.912887874 -14.9098206841 -89.4845837792 3.912887874 -14.9148206841 -89.4845837792 3.912887874 -14.9198206841 -89.4845837792 3.912887874 -14.9248206841 -89.4845837792 3.912887874 -14.9298206841 -89.4845837792 3.912887874 -14.9348206841 -89.4845837792 3.912887874 -14.9398206841 -89.4845837792 3.912887874 -14.9448206841 -89.4845837792 3.912887874 -14.9498206841 -89.4845837792 3.912887874 -14.9548206841 -89.4845837792 3.912887874 -14.9598206841 -89.4845837792 3.912887874 -14.9648206841 -89.4845837792 3.912887874 -14.9698206841 -89.4845837792 3.912887874 -14.9748206841 -89.4845837792 3.912887874 -14.9798206841 -89.4845837792 3.912887874 -14.9848206841 -89.4845837792 3.912887874 -14.9898206841 -89.4845837792 3.912887874 -14.9948206841 -89.4845837792 3.912887874 -14.9998206841 -89.4845837792 3.912887874 -15.0048206841 -89.4845837792 3.912887874 -15.0098206841 -89.4845837792 3.912887874 -15.0148206841 -89.4845837792 3.912887874 -15.0198206841 -89.4845837792 3.912887874 -15.0248206841 -89.4845837792 3.912887874 -15.0298206841 -89.4845837792 3.912887874 -15.0348206841 -89.4845837792 3.912887874 -15.0398206841 -89.4845837792 3.912887874 -15.0448206841 -89.4845837792 3.912887874 -15.0498206841 -89.4845837792 3.912887874 -15.0548206841 -89.4845837792 3.912887874 -15.0598206841 -89.4845837792 3.912887874 -15.0648206841 -89.4845837792 3.912887874 -15.0698206841 -89.4845837792 3.912887874 -15.0748206841 -89.4845837792 3.912887874 -15.0798206841 -89.4845837792 3.912887874 -15.0848206841 -89.4845837792 3.912887874 -15.0898206841 -89.4845837792 3.912887874 -15.0948206841 -89.4845837792 3.912887874 -15.0998206841 -89.4845837792 3.912887874 -15.1048206841 -89.4845837792 3.912887874 -15.1098206841 -89.4845837792 3.912887874 -15.1148206841 -89.4845837792 3.912887874 -15.1198206841 -89.4845837792 3.912887874 -15.1248206841 -89.4845837792 3.912887874 -15.1298206841 -89.4845837792 3.912887874 -15.1348206841 -89.4845837792 3.912887874 -15.1398206841 -89.4845837792 3.912887874 -15.1448206841 -89.4845837792 3.912887874 -15.1498206841 -89.4845837792 3.912887874 -15.1548206841 -89.4845837792 3.912887874 -15.1598206841 -89.4845837792 3.912887874 -15.1648206841 -89.4845837792 3.912887874 -15.1698206841 -89.4845837792 3.912887874 -15.1748206841 -89.4845837792 3.912887874 -15.1798206841 -89.4845837792 3.912887874 -15.1848206841 -89.4845837792 3.912887874 -15.1898206841 -89.4845837792 3.912887874 -15.1948206841 -89.4845837792 3.912887874 -15.1998206841 -89.4845837792 3.912887874 -15.2048206841 -89.4845837792 3.912887874 -15.2098206841 -89.4845837792 3.912887874 -15.2148206841 -89.4845837792 3.912887874 -15.2198206841 -89.4845837792 3.912887874 -15.2248206841 -89.4845837792 3.912887874 -15.2298206841 -89.4845837792 3.912887874 -15.2348206841 -89.4845837792 3.912887874 -15.2398206841 -89.4845837792 3.912887874 -15.2448206841 -89.4845837792 3.912887874 -15.2498206841 -89.4845837792 3.912887874 -15.2548206841 -89.4845837792 3.912887874 -15.2598206841 -89.4845837792 3.912887874 -15.2648206841 -89.4845837792 3.912887874 -15.2698206841 -89.4845837792 3.912887874 -15.2748206841 -89.4845837792 3.912887874 -15.2798206841 -89.4845837792 3.912887874 -15.2848206841 -89.4845837792 3.912887874 -15.2898206841 -89.4845837792 3.912887874 -15.2948206841 -89.4845837792 3.912887874 -15.2998206841 -89.4845837792 3.912887874 -15.3048206841 -89.4845837792 3.912887874 -15.3098206841 -89.4845837792 3.912887874 -15.3148206841 -89.4845837792 3.912887874 -15.3198206841 -89.4845837792 3.912887874 -15.3248206841 -89.4845837792 3.912887874 -15.3298206841 -89.4845837792 3.912887874 -15.3348206841 -89.4845837792 3.912887874 -15.3398206841 -89.4845837792 3.912887874 -15.3448206841 -89.4845837792 3.912887874 -15.3498206841 -89.4845837792 3.912887874 -15.3548206841 -89.4845837792 3.912887874 -15.3598206841 -89.4845837792 3.912887874 -15.3648206841 -89.4845837792 3.912887874 -15.3698206841 -89.4845837792 3.912887874 -15.3748206841 -89.4845837792 3.912887874 -15.3798206841 -89.4845837792 3.912887874 -15.3848206841 -89.4845837792 3.912887874 -15.3898206841 -89.4845837792 3.912887874 -15.3948206841 -89.4845837792 3.912887874 -15.3998206841 -89.4845837792 3.912887874 -15.4048206841 -89.4845837792 3.912887874 -15.4098206841 -89.4845837792 3.912887874 -15.4148206841 -89.4845837792 3.912887874 -15.4198206841 -89.4845837792 3.912887874 -15.4248206841 -89.4845837792 3.912887874 -15.4298206841 -89.4845837792 3.912887874 -15.4348206841 -89.4845837792 3.912887874 -15.4398206841 -89.4845837792 3.912887874 -15.4448206841 -89.4845837792 3.912887874 -15.4498206841 -89.4845837792 3.912887874 -15.4548206841 -89.4845837792 3.912887874 -15.4598206841 -89.4845837792 3.912887874 -15.4648206841 -89.4845837792 3.912887874 -15.4698206841 -89.4845837792 3.912887874 -15.4748206841 -89.4845837792 3.912887874 -15.4798206841 -89.4845837792 3.912887874 -15.4848206841 -89.4845837792 3.912887874 -15.4898206841 -89.4845837792 3.912887874 -15.4948206841 -89.4845837792 3.912887874 -15.4998206841 -89.4845837792 3.912887874 -15.5048206841 -89.4845837792 3.912887874 -15.5098206841 -89.4845837792 3.912887874 -15.5148206841 -89.4845837792 3.912887874 -15.5198206841 -89.4845837792 3.912887874 -15.5248206841 -89.4845837792 3.912887874 -15.5298206841 -89.4845837792 3.912887874 -15.5348206841 -89.4845837792 3.912887874 -15.5398206841 -89.4845837792 3.912887874 -15.5448206841 -89.4845837792 3.912887874 -15.5498206841 -89.4845837792 3.912887874 -15.5548206841 -89.4845837792 3.912887874 -15.5598206841 -89.4845837792 3.912887874 -15.5648206841 -89.4845837792 3.912887874 -15.5698206841 -89.4845837792 3.912887874 -15.5748206841 -89.4845837792 3.912887874 -15.5798206841 -89.4845837792 3.912887874 -15.5848206841 -89.4845837792 3.912887874 -15.5898206841 -89.4845837792 3.912887874 -15.5948206841 -89.4845837792 3.912887874 -15.5998206841 -89.4845837792 3.912887874 -15.6048206841 -89.4845837792 3.912887874 -15.6098206841 -89.4845837792 3.912887874 -15.6148206841 -89.4845837792 3.912887874 -15.6198206841 -89.4845837792 3.912887874 -15.6248206841 -89.4845837792 3.912887874 -15.6298206841 -89.4845837792 3.912887874 -15.6348206841 -89.4845837792 3.912887874 -15.6398206841 -89.4845837792 3.912887874 -15.6448206841 -89.4845837792 3.912887874 -15.6498206841 -89.4845837792 3.912887874 -15.6548206841 -89.4845837792 3.912887874 -15.6598206841 -89.4845837792 3.912887874 -15.6648206841 -89.4845837792 3.912887874 -15.6698206841 -89.4845837792 3.912887874 -15.6748206841 -89.4845837792 3.912887874 -15.6798206841 -89.4845837792 3.912887874 -15.6848206841 -89.4845837792 3.912887874 -15.6898206841 -89.4845837792 3.912887874 -15.6948206841 -89.4845837792 3.912887874 -15.6998206841 -89.4845837792 3.912887874 -15.7048206841 -89.4845837792 3.912887874 -15.7098206841 -89.4845837792 3.912887874 -15.7148206841 -89.4845837792 3.912887874 -15.7198206841 -89.4845837792 3.912887874 -15.7248206841 930.391916571 3.912887874 -15.7298206841 322.941669033 3.912887874 -15.7348206841 101.825848616 3.912887874 -15.7398206841 119.781740504 3.912887874 -15.7448206841 405.068181545 3.912887874 -15.7498206841 589.564889835 3.912887874 -15.7548206841 1266.13230094 3.912887874 -15.7598206841 2223.37386099 3.912887874 -15.7648206841 2101.98834371 3.912887874 -15.7698206841 2386.94278467 3.912887874 -15.7748206841 2221.93382489 3.912887874 -15.7798206841 1821.19841669 3.912887874 -15.7848206841 1329.87864793 3.912887874 -15.7898206841 1028.07794285 3.912887874 -15.7948206841 747.734265517 3.912887874 -15.7998206841 551.618061792 3.912887874 -15.8048206841 406.037624555 3.912887874 -15.8098206841 319.316852353 3.912887874 -15.8148206841 275.047708155 3.912887874 -15.8198206841 267.259405343 3.912887874 -15.8248206841 288.847571737 3.912887874 -15.8298206841 314.526501845 3.912887874 -15.8348206841 356.376684485 3.912887874 -15.8398206841 395.825042255 3.912887874 -15.8448206841 450.587758358 3.912887874 -15.8498206841 510.398391742 3.912887874 -15.8548206841 554.503483508 3.912887874 -15.8598206841 589.687107759 3.912887874 -15.8648206841 611.01768783 3.912887874 -15.8698206841 620.720578616 3.912887874 -15.8748206841 612.687619307 3.912887874 -15.8798206841 605.430190992 3.912887874 -15.8848206841 593.997824975 3.912887874 -15.8898206841 580.688427847 3.912887874 -15.8948206841 568.197903305 3.51208628013 -15.8998206841 553.198091433 3.48571020642 -15.9048206841 539.680064806 3.45507382526 -15.9098206841 530.806464855 3.41970730801 -15.9148206841 524.253662081 3.41970730801 -15.9198206841 520.302759265 3.41970730801 -15.9248206841 518.79847047 3.41970730801 -15.9298206841 519.676482515 3.41970730801 -15.9348206841 520.416427132 3.41970730801 -15.9398206841 524.288268171 3.41970730801 -15.9448206841 531.383221849 3.41970730801 -15.9498206841 534.976155151 3.41970730801 -15.9548206841 541.033113326 3.41970730801 -15.9598206841 547.194906403 3.41970730801 -15.9648206841 553.744053881 3.41970730801 -15.9698206841 560.899814042 3.41970730801 -15.9748206841 568.168553263 3.41970730801 -15.9798206841 579.953072085 3.41970730801 -15.9848206841 591.106369955 3.41970730801 -15.9898206841 600.463667167 3.41970730801 -15.9948206841 610.070839426 3.41970730801 -15.9998206841 627.082242642 3.41970730801 -16.0048206841 635.879391068 3.41970730801 -16.0098206841 652.629794942 3.41970730801 -16.0148206841 669.633302276 3.41970730801 -16.0198206841 692.456575086 3.41970730801 -16.0248206841 707.414675426 1.39260005303 -16.0298206841 729.017298114 1.39260005303 -16.0348206841 742.273743523 0.487143862815 -16.0398206841 766.099350072 0.487143862815 -16.0448206841 784.790397167 0.487143862815 -16.0498206841 802.741838379 0.487143862815 -16.0548206841 817.039440424 0.2954516133 -16.0598206841 851.938729586 0.2954516133 -16.0648206841 855.811169086 0.2954516133 -16.0698206841 855.811169086 0.2954516133 -16.0748206841 878.550960118 0.2954516133 -16.0798206841 887.009231395 0.2954516133 -16.0848206841 842.285673621 0.2954516133 -16.0898206841 828.303771636 0.2954516133 -16.0948206841 796.944097505 0.2954516133 -16.0998206841 759.677377915 0.2954516133 -16.1048206841 728.457155679 0.2954516133 -16.1098206841 693.495846349 0.2954516133 -16.1148206841 657.954616721 0.2954516133 -16.1198206841 633.108795604 0.2954516133 -16.1248206841 606.619696906 0.2954516133 -16.1298206841 554.917292171 0.2954516133 -16.1348206841 545.333114033 0.2954516133 -16.1398206841 515.986771941 0.2954516133 -16.1448206841 493.349219011 0.2954516133 -16.1498206841 479.30543346 0.2954516133 -16.1548206841 465.348438505 0.2954516133 -16.1598206841 500.484428014 0.2954516133 -16.1648206841 463.713882687 0.2954516133 -16.1698206841 433.097999179 0.2954516133 -16.1748206841 429.389771928 0.2954516133 -16.1798206841 426.913712083 0.2954516133 -16.1848206841 456.551472453 0.2954516133 -16.1898206841 501.368516622 0.2954516133 -16.1948206841 463.900865348 0.2954516133 -16.1998206841 433.015333391 0.2954516133 -16.2048206841 447.797125042 0.2954516133 -16.2098206841 457.871697351 0.2954516133 -16.2148206841 459.695026691 0.2954516133 -16.2198206841 457.918108719 0.2954516133 -16.2248206841 461.515257519 0.2954516133 -16.2298206841 473.695225251 0.2954516133 -16.2348206841 470.018262346 0.2954516133 -16.2398206841 471.071514267 0.2954516133 -16.2448206841 470.476801363 0.2954516133 -16.2498206841 468.479439944 0.2954516133 -16.2548206841 470.23648389 0.2954516133 -16.2598206841 473.589073013 0.2954516133 -16.2648206841 476.56876451 0.2954516133 -16.2698206841 476.77919535 0.2954516133 -16.2748206841 485.507286257 0.2954516133 -16.2798206841 477.677835776 0.2954516133 -16.2848206841 471.61217351 0.2954516133 -16.2898206841 461.845170317 0.2954516133 -16.2948206841 449.545324185 0.2954516133 -16.2998206841 439.370516137 0.2954516133 -16.3048206841 435.66405605 0.2954516133 -16.3098206841 436.579934137 0.2954516133 -16.3148206841 426.757677261 0.2954516133 -16.3198206841 441.296446373 0.2954516133 -16.3248206841 435.761040388 0.2954516133 -16.3298206841 428.412655402 0.2954516133 -16.3348206841 424.220143814 0.2954516133 -16.3398206841 423.351893455 0.2954516133 -16.3448206841 420.884917141 0.2954516133 -16.3498206841 418.896652216 0.2954516133 -16.3548206841 415.124178149 0.2954516133 -16.3598206841 411.026600196 0.2954516133 -16.3648206841 410.815463697 0.2954516133 -16.3698206841 410.56532768 0.2954516133 -16.3748206841 410.35603411 0.2954516133 -16.3798206841 409.875929189 0.2954516133 -16.3848206841 406.943619462 0.2954516133 -16.3898206841 400.710658292 0.2954516133 -16.3948206841 396.605303861 0.2954516133 -16.3998206841 391.68306845 0.2954516133 -16.4048206841 384.143094792 0.2954516133 -16.4098206841 383.9982991 0.2954516133 -16.4148206841 374.775791826 0.2954516133 -16.4198206841 358.950810756 0.2954516133 -16.4248206841 358.257573196 0.2954516133 -16.4298206841 340.737717839 0.2954516133 -16.4348206841 342.37460524 0.2954516133 -16.4398206841 332.461213022 0.2954516133 -16.4448206841 327.609082186 0.2954516133 -16.4498206841 322.506863628 0.2954516133 -16.4548206841 316.689084091 0.2954516133 -16.4598206841 315.157677692 0.2954516133 -16.4648206841 308.222690976 0.2954516133 -16.4698206841 302.198466164 0.2954516133 -16.4748206841 294.508942552 0.2954516133 -16.4798206841 288.768610459 0.2954516133 -16.4848206841 286.31001615 0.2954516133 -16.4898206841 281.375215302 0.2954516133 -16.4948206841 278.430248116 0.2954516133 -16.4998206841 273.376475221 0.2954516133 -16.5048206841 267.498294843 0.2954516133 -16.5098206841 263.228508855 0.2954516133 -16.5148206841 260.954176314 0.2954516133 -16.5198206841 255.929734954 0.2954516133 -16.5248206841 247.570808482 0.2954516133 -16.5298206841 241.141901096 0.2954516133 -16.5348206841 236.141586206 0.2954516133 -16.5398206841 228.126084907 0.2954516133 -16.5448206841 218.605721198 0.2954516133 -16.5498206841 209.458610634 0.2954516133 -16.5548206841 197.488114452 0.2954516133 -16.5598206841 186.374704545 0.2954516133 -16.5648206841 176.851998983 0.2954516133 -16.5698206841 164.710359698 0.2954516133 -16.5748206841 151.045987287 0.2954516133 -16.5798206841 138.899508189 0.2954516133 -16.5848206841 131.855369047 0.2954516133 -16.5898206841 120.811760801 0.2954516133 -16.5948206841 112.031110442 0.2954516133 -16.5998206841 103.354425729 0.2954516133 -16.6048206841 95.4208338572 0.2954516133 -16.6098206841 98.0624301102 0.2954516133 -16.6148206841 90.5793923493 0.2954516133 -16.6198206841 82.4262636773 0.2954516133 -16.6248206841 71.3323441476 0.2954516133 -16.6298206841 58.1688425225 0.2954516133 -16.6348206841 64.1396465834 0.2954516133 -16.6398206841 42.357256398 0.2954516133 -16.6448206841 52.9113757309 0.2954516133 -16.6498206841 27.0625575526 0.2954516133 -16.6548206841 39.3801541105 0.2954516133 -16.6598206841 28.7630799225 0.2954516133 -16.6648206841 14.4304898912 0.2954516133 -16.6698206841 -18.2726444642 0.2954516133 -16.6748206841 -11.3342783459 0.2954516133 -16.6798206841 -13.1602057237 0.2954516133 -16.6848206841 -20.2074569282 0.2954516133 -16.6898206841 -26.2212192774 0.2954516133 -16.6948206841 -34.3496789992 0.2954516133 -16.6998206841 -44.6128181625 0.2954516133 -16.7048206841 -68.4666776448 0.2954516133 -16.7098206841 -68.4666776448 0.2954516133 -16.7148206841 -68.4666776448 0.2954516133 -16.7198206841 -68.4666776448 0.2954516133 -16.7248206841 -68.4666776448 0.2954516133 -16.7298206841 -68.4666776448 0.2954516133 -16.7348206841 -68.4666776448 0.2954516133 -16.7398206841 -68.4666776448 0.2954516133 -16.7448206841 -68.4666776448 0.2954516133 -16.7498206841 -68.4666776448 0.2954516133 -16.7548206841 -68.4666776448 0.2954516133 -16.7598206841 -68.4666776448 0.2954516133 -16.7648206841 -68.4666776448 0.2954516133 -16.7698206841 -68.4666776448 0.2954516133 -16.7748206841 -68.4666776448 0.2954516133 -16.7798206841 -68.4666776448 0.2954516133 -16.7848206841 -68.4666776448 0.2954516133 -16.7898206841 -68.4666776448 0.2954516133 -16.7948206841 -68.4666776448 0.2954516133 -16.7998206841 -68.4666776448 0.2954516133 -16.8048206841 -68.4666776448 0.2954516133 -16.8098206841 -68.4666776448 0.2954516133 -16.8148206841 -68.4666776448 0.2954516133 -16.8198206841 -68.4666776448 0.2954516133 -16.8248206841 -68.4666776448 0.2954516133 -16.8298206841 -68.4666776448 0.2954516133 -16.8348206841 -68.4666776448 0.2954516133 -16.8398206841 -68.4666776448 0.2954516133 -16.8448206841 -68.4666776448 0.2954516133 -16.8498206841 -68.4666776448 0.2954516133 -16.8548206841 -68.4666776448 0.2954516133 -16.8598206841 -68.4666776448 0.2954516133 -16.8648206841 -68.4666776448 0.2954516133 -16.8698206841 -68.4666776448 0.2954516133 -16.8748206841 -68.4666776448 0.2954516133 -16.8798206841 -68.4666776448 0.2954516133 -16.8848206841 -68.4666776448 0.2954516133 -16.8898206841 -68.4666776448 0.2954516133 -16.8948206841 -68.4666776448 0.2954516133 -16.8998206841 -68.4666776448 0.2954516133 -16.9048206841 -68.4666776448 0.2954516133 -16.9098206841 -68.4666776448 0.2954516133 -16.9148206841 -68.4666776448 0.2954516133 -16.9198206841 -68.4666776448 0.2954516133 -16.9248206841 -68.4666776448 0.2954516133 -16.9298206841 -68.4666776448 0.2954516133 -16.9348206841 -68.4666776448 0.2954516133 -16.9398206841 -68.4666776448 0.2954516133 -16.9448206841 -68.4666776448 0.2954516133 -16.9498206841 -68.4666776448 0.2954516133 -16.9548206841 -68.4666776448 0.2954516133 -16.9598206841 -68.4666776448 0.2954516133 -16.9648206841 -68.4666776448 0.2954516133 -16.9698206841 -68.4666776448 0.2954516133 -16.9748206841 -68.4666776448 0.2954516133 -16.9798206841 -68.4666776448 0.2954516133 -16.9848206841 -68.4666776448 0.2954516133 -16.9898206841 -68.4666776448 0.2954516133 -16.9948206841 -68.4666776448 0.2954516133 -16.9998206841 -68.4666776448 0.2954516133 -17.0048206841 -68.4666776448 0.2954516133 -17.0098206841 -68.4666776448 0.2954516133 -17.0148206841 -68.4666776448 0.2954516133 -17.0198206841 -68.4666776448 0.2954516133 -17.0248206841 -68.4666776448 0.2954516133 -17.0298206841 -68.4666776448 0.2954516133 -17.0348206841 -68.4666776448 0.2954516133 -17.0398206841 -68.4666776448 0.2954516133 -17.0448206841 -68.4666776448 0.2954516133 -17.0498206841 -68.4666776448 0.2954516133 -17.0548206841 -68.4666776448 0.2954516133 -17.0598206841 -68.4666776448 0.2954516133 -17.0648206841 -68.4666776448 0.2954516133 -17.0698206841 -68.4666776448 0.2954516133 -17.0748206841 -68.4666776448 0.2954516133 -17.0798206841 -68.4666776448 0.2954516133 -17.0848206841 -68.4666776448 0.2954516133 -17.0898206841 -68.4666776448 0.2954516133 -17.0948206841 -68.4666776448 0.2954516133 -17.0998206841 -68.4666776448 0.2954516133 -17.1048206841 -68.4666776448 0.2954516133 -17.1098206841 -68.4666776448 0.2954516133 -17.1148206841 -68.4666776448 0.2954516133 -17.1198206841 -68.4666776448 0.2954516133 -17.1248206841 -68.4666776448 0.2954516133 -17.1298206841 -68.4666776448 0.2954516133 -17.1348206841 -68.4666776448 0.2954516133 -17.1398206841 -68.4666776448 0.2954516133 -17.1448206841 -68.4666776448 0.2954516133 -17.1498206841 -68.4666776448 0.2954516133 -17.1548206841 -68.4666776448 0.2954516133 -17.1598206841 -68.4666776448 0.2954516133 -17.1648206841 -68.4666776448 0.2954516133 -17.1698206841 -68.4666776448 0.2954516133 -17.1748206841 -68.4666776448 0.2954516133 -17.1798206841 -68.4666776448 0.2954516133 -17.1848206841 -68.4666776448 0.2954516133 -17.1898206841 -68.4666776448 0.2954516133 -17.1948206841 -68.4666776448 0.2954516133 -17.1998206841 -68.4666776448 0.2954516133 -17.2048206841 -68.4666776448 0.2954516133 -17.2098206841 -68.4666776448 0.2954516133 -17.2148206841 -68.4666776448 0.2954516133 -17.2198206841 -68.4666776448 0.2954516133 -17.2248206841 -68.4666776448 0.2954516133 -17.2298206841 -68.4666776448 0.2954516133 -17.2348206841 -68.4666776448 0.2954516133 -17.2398206841 -68.4666776448 0.2954516133 -17.2448206841 -68.4666776448 0.2954516133 -17.2498206841 -68.4666776448 0.2954516133 -17.2548206841 -68.4666776448 0.2954516133 -17.2598206841 -68.4666776448 0.2954516133 -17.2648206841 -68.4666776448 0.2954516133 -17.2698206841 -68.4666776448 0.2954516133 -17.2748206841 -68.4666776448 0.2954516133 -17.2798206841 -68.4666776448 0.2954516133 -17.2848206841 -68.4666776448 0.2954516133 -17.2898206841 -68.4666776448 0.2954516133 -17.2948206841 -68.4666776448 0.2954516133 -17.2998206841 -68.4666776448 0.2954516133 -17.3048206841 -68.4666776448 0.2954516133 -17.3098206841 -68.4666776448 0.2954516133 -17.3148206841 -68.4666776448 0.2954516133 -17.3198206841 -68.4666776448 0.2954516133 -17.3248206841 -68.4666776448 0.2954516133 -17.3298206841 -68.4666776448 0.2954516133 -17.3348206841 -68.4666776448 0.2954516133 -17.3398206841 -68.4666776448 0.2954516133 -17.3448206841 -68.4666776448 0.2954516133 -17.3498206841 -68.4666776448 0.2954516133 -17.3548206841 -68.4666776448 0.2954516133 -17.3598206841 -68.4666776448 0.2954516133 -17.3648206841 -68.4666776448 0.2954516133 -17.3698206841 -68.4666776448 0.2954516133 -17.3748206841 -68.4666776448 0.2954516133 -17.3798206841 -68.4666776448 0.2954516133 -17.3848206841 -68.4666776448 0.2954516133 -17.3898206841 -68.4666776448 0.2954516133 -17.3948206841 -68.4666776448 0.2954516133 -17.3998206841 -68.4666776448 0.2954516133 -17.4048206841 -68.4666776448 0.2954516133 -17.4098206841 -68.4666776448 0.2954516133 -17.4148206841 -68.4666776448 0.2954516133 -17.4198206841 -68.4666776448 0.2954516133 -17.4248206841 -68.4666776448 0.2954516133 -17.4298206841 -68.4666776448 0.2954516133 -17.4348206841 -68.4666776448 0.2954516133 -17.4398206841 -68.4666776448 0.2954516133 -17.4448206841 -68.4666776448 0.2954516133 -17.4498206841 -68.4666776448 0.2954516133 -17.4548206841 -68.4666776448 0.2954516133 -17.4598206841 -68.4666776448 0.2954516133 -17.4648206841 -68.4666776448 0.2954516133 -17.4698206841 -68.4666776448 0.2954516133 -17.4748206841 -68.4666776448 0.2954516133 -17.4798206841 -68.4666776448 0.2954516133 -17.4848206841 -68.4666776448 0.2954516133 -17.4898206841 -68.4666776448 0.2954516133 -17.4948206841 -68.4666776448 0.2954516133 -17.4998206841 -68.4666776448 0.2954516133 -17.5048206841 -68.4666776448 0.2954516133 -17.5098206841 -68.4666776448 0.2954516133 -17.5148206841 -68.4666776448 0.2954516133 -17.5198206841 -68.4666776448 0.2954516133 -17.5248206841 -68.4666776448 0.2954516133 -17.5298206841 -68.4666776448 0.2954516133 -17.5348206841 -68.4666776448 0.2954516133 -17.5398206841 -68.4666776448 0.2954516133 -17.5448206841 -68.4666776448 0.2954516133 -17.5498206841 -68.4666776448 0.2954516133 -17.5548206841 -68.4666776448 0.2954516133 -17.5598206841 -68.4666776448 0.2954516133 -17.5648206841 -68.4666776448 0.2954516133 -17.5698206841 -68.4666776448 0.2954516133 -17.5748206841 -68.4666776448 0.2954516133 -17.5798206841 -68.4666776448 0.2954516133 -17.5848206841 -68.4666776448 0.2954516133 -17.5898206841 -68.4666776448 0.2954516133 -17.5948206841 -68.4666776448 0.2954516133 -17.5998206841 -68.4666776448 0.2954516133 -17.6048206841 -68.4666776448 0.2954516133 -17.6098206841 -68.4666776448 0.2954516133 -17.6148206841 -68.4666776448 0.2954516133 -17.6198206841 -68.4666776448 0.2954516133 -17.6248206841 -68.4666776448 0.2954516133 -17.6298206841 -68.4666776448 0.2954516133 -17.6348206841 -68.4666776448 0.2954516133 -17.6398206841 1720.50103325 0.2954516133 -17.6448206841 411.65225197 0.2954516133 -17.6498206841 246.614613684 0.2954516133 -17.6548206841 291.554108786 0.2954516133 -17.6598206841 583.533662221 0.2954516133 -17.6648206841 655.560129774 0.2954516133 -17.6698206841 779.684584338 0.2954516133 -17.6748206841 1248.74229169 0.2954516133 -17.6798206841 1230.05110141 0.2954516133 -17.6848206841 1526.05009878 0.2954516133 -17.6898206841 1667.83892367 0.2954516133 -17.6948206841 1646.94654914 0.2954516133 -17.6998206841 1457.10337502 0.2954516133 -17.7048206841 1250.62360708 0.2954516133 -17.7098206841 1051.93304717 0.2954516133 -17.7148206841 832.698805131 0.2954516133 -17.7198206841 689.244931124 0.2954516133 -17.7248206841 554.06530597 0.2954516133 -17.7298206841 468.374857612 0.2954516133 -17.7348206841 414.51902991 0.2954516133 -17.7398206841 394.227466429 0.2954516133 -17.7448206841 388.287546324 0.2954516133 -17.7498206841 388.240876302 0.2954516133 -17.7548206841 425.836663885 0.2954516133 -17.7598206841 460.383550236 0.2954516133 -17.7648206841 498.421071916 0.2954516133 -17.7698206841 529.210540988 0.2954516133 -17.7748206841 555.835328369 0.2954516133 -17.7798206841 583.290994054 0.2954516133 -17.7848206841 599.038423879 0.2954516133 -17.7898206841 606.022121536 0.2954516133 -17.7948206841 606.866313893 0.2954516133 -17.7998206841 607.610775108 3.04953080886 -17.8048206841 606.712368178 2.60613713864 -17.8098206841 601.146034014 2.34238525273 -17.8148206841 592.181012952 2.017353105 -17.8198206841 586.559458974 2.017353105 -17.8248206841 579.159172685 2.017353105 -17.8298206841 576.441377782 2.017353105 -17.8348206841 570.616520086 2.017353105 -17.8398206841 567.231221548 2.017353105 -17.8448206841 569.286178765 2.017353105 -17.8498206841 570.760416238 2.017353105 -17.8548206841 574.791167388 2.017353105 -17.8598206841 579.756287278 2.017353105 -17.8648206841 583.06320236 2.017353105 -17.8698206841 592.968447101 2.017353105 -17.8748206841 595.235938979 2.017353105 -17.8798206841 604.002633799 2.017353105 -17.8848206841 602.621416432 2.017353105 -17.8898206841 620.617986733 2.017353105 -17.8948206841 624.661750751 2.017353105 -17.8998206841 624.218397475 2.017353105 -17.9048206841 646.530501345 2.017353105 -17.9098206841 647.616745843 2.017353105 -17.9148206841 659.064740424 2.017353105 -17.9198206841 673.390783588 2.017353105 -17.9248206841 679.303157781 2.017353105 -17.9298206841 686.912836633 2.017353105 -17.9348206841 699.026375102 2.017353105 -17.9398206841 712.509209664 2.017353105 -17.9448206841 726.991892389 2.017353105 -17.9498206841 734.31440239 2.017353105 -17.9548206841 751.842888709 2.017353105 -17.9598206841 774.330700242 2.017353105 -17.9648206841 787.883286927 2.017353105 -17.9698206841 818.51777276 2.017353105 -17.9748206841 820.359287832 2.017353105 -17.9798206841 871.100120146 2.017353105 -17.9848206841 874.052452604 2.017353105 -17.9898206841 887.804351298 2.017353105 -17.9948206841 925.537049235 2.017353105 -17.9998206841 881.650663582 2.017353105 -18.0048206841 935.299442232 2.017353105 -18.0098206841 949.427665188 2.017353105 -18.0148206841 925.649655341 2.017353105 -18.0198206841 902.36004821 2.017353105 -18.0248206841 896.45516648 2.017353105 -18.0298206841 853.401300193 2.017353105 -18.0348206841 838.674421037 2.017353105 -18.0398206841 795.909544525 2.017353105 -18.0448206841 747.275130818 2.017353105 -18.0498206841 686.740045218 -0.653009209933 -18.0548206841 656.186338971 -0.746707311278 -18.0598206841 621.011938989 -0.852466697315 -18.0648206841 580.506931306 -0.852466697315 -18.0698206841 567.622764611 -0.852466697315 -18.0748206841 535.66110074 -0.852466697315 -18.0798206841 523.893776789 -0.852466697315 -18.0848206841 522.362079113 -0.852466697315 -18.0898206841 519.566082154 -0.852466697315 -18.0948206841 514.403210885 -0.852466697315 -18.0998206841 510.059760838 -0.852466697315 -18.1048206841 508.659729243 -0.852466697315 -18.1098206841 507.951713518 -0.852466697315 -18.1148206841 504.663519873 -0.852466697315 -18.1198206841 497.884291064 -0.852466697315 -18.1248206841 487.721086547 -0.852466697315 -18.1298206841 475.691690416 -0.852466697315 -18.1348206841 462.264275735 -0.852466697315 -18.1398206841 450.280696452 -0.852466697315 -18.1448206841 436.371260743 -0.852466697315 -18.1498206841 497.981353132 -0.852466697315 -18.1548206841 492.208028689 -0.852466697315 -18.1598206841 436.203648969 -0.852466697315 -18.1648206841 415.27842633 -0.852466697315 -18.1698206841 400.192442623 -0.852466697315 -18.1748206841 362.614670144 -0.852466697315 -18.1798206841 331.782230249 -0.852466697315 -18.1848206841 314.013772786 -0.852466697315 -18.1898206841 295.314929393 -0.852466697315 -18.1948206841 286.667276384 -0.852466697315 -18.1998206841 268.501980371 -0.852466697315 -18.2048206841 258.359793038 -0.852466697315 -18.2098206841 254.707031448 -0.852466697315 -18.2148206841 246.507036875 -0.852466697315 -18.2198206841 258.699510411 -0.852466697315 -18.2248206841 264.807831448 -0.852466697315 -18.2298206841 274.044642779 -0.852466697315 -18.2348206841 304.868274012 -0.852466697315 -18.2398206841 324.510853409 -0.852466697315 -18.2448206841 334.840461524 -0.852466697315 -18.2498206841 358.238358695 -0.852466697315 -18.2548206841 377.63550348 -0.852466697315 -18.2598206841 397.859317931 -0.852466697315 -18.2648206841 409.738165967 -0.852466697315 -18.2698206841 417.232983537 -0.852466697315 -18.2748206841 420.55605051 -0.852466697315 -18.2798206841 418.303887535 -0.852466697315 -18.2848206841 416.88495592 -0.852466697315 -18.2898206841 413.62943161 -0.852466697315 -18.2948206841 404.075565538 -0.852466697315 -18.2998206841 397.540794593 -0.852466697315 -18.3048206841 387.133374833 -0.852466697315 -18.3098206841 373.941820068 -0.852466697315 -18.3148206841 362.642832236 -0.852466697315 -18.3198206841 351.050126179 -0.852466697315 -18.3248206841 342.200433192 -0.852466697315 -18.3298206841 334.53709191 -0.852466697315 -18.3348206841 328.4065188 -0.852466697315 -18.3398206841 321.608470486 -0.852466697315 -18.3448206841 319.477599505 -0.852466697315 -18.3498206841 316.246738399 -0.852466697315 -18.3548206841 315.983419111 -0.852466697315 -18.3598206841 313.793885922 -0.852466697315 -18.3648206841 314.078257027 -0.852466697315 -18.3698206841 313.228897159 -0.852466697315 -18.3748206841 312.044271343 -0.852466697315 -18.3798206841 309.242688143 -0.852466697315 -18.3848206841 305.060153963 -0.852466697315 -18.3898206841 301.96731365 -0.852466697315 -18.3948206841 296.717622273 -0.852466697315 -18.3998206841 297.922366552 -0.852466697315 -18.4048206841 288.021379382 -0.852466697315 -18.4098206841 280.136743937 -0.852466697315 -18.4148206841 275.421999164 -0.852466697315 -18.4198206841 270.385242053 -0.852466697315 -18.4248206841 264.396606833 -0.852466697315 -18.4298206841 256.830445869 -0.852466697315 -18.4348206841 254.811067788 -0.852466697315 -18.4398206841 250.22098597 -0.852466697315 -18.4448206841 245.536620397 -0.852466697315 -18.4498206841 240.230988967 -0.852466697315 -18.4548206841 233.724396428 -0.852466697315 -18.4598206841 226.956547726 -0.852466697315 -18.4648206841 215.681693779 -0.852466697315 -18.4698206841 201.84240521 -0.852466697315 -18.4748206841 191.757920926 -0.852466697315 -18.4798206841 181.325823129 -0.852466697315 -18.4848206841 171.503773923 -0.852466697315 -18.4898206841 161.398364208 -0.852466697315 -18.4948206841 151.75225833 -0.852466697315 -18.4998206841 141.652986232 -0.852466697315 -18.5048206841 131.555231836 -0.852466697315 -18.5098206841 123.477643208 -0.852466697315 -18.5148206841 114.447872748 -0.852466697315 -18.5198206841 108.123417417 -0.852466697315 -18.5248206841 99.9834562797 -0.852466697315 -18.5298206841 94.3141968107 -0.852466697315 -18.5348206841 82.2173994677 -0.852466697315 -18.5398206841 66.0073492075 -0.852466697315 -18.5448206841 49.719290538 -0.852466697315 -18.5498206841 33.9286467057 -0.852466697315 -18.5548206841 19.6470575111 -0.852466697315 -18.5598206841 3.75409746525 -0.852466697315 -18.5648206841 -10.692034907 -0.852466697315 -18.5698206841 -18.4571672789 -0.852466697315 -18.5748206841 -30.3213937911 -0.852466697315 -18.5798206841 -36.7146915591 -0.852466697315 -18.5848206841 -46.7244928507 -0.852466697315 -18.5898206841 -50.5390959075 -0.852466697315 -18.5948206841 -53.152705009 -0.852466697315 -18.5998206841 -63.7259526046 -0.852466697315 -18.6048206841 -63.7259526046 -0.852466697315 -18.6098206841 -63.7259526046 -0.852466697315 -18.6148206841 -63.7259526046 -0.852466697315 -18.6198206841 -63.7259526046 -0.852466697315 -18.6248206841 -63.7259526046 -0.852466697315 -18.6298206841 -63.7259526046 -0.852466697315 -18.6348206841 -63.7259526046 -0.852466697315 -18.6398206841 -63.7259526046 -0.852466697315 -18.6448206841 -63.7259526046 -0.852466697315 -18.6498206841 -63.7259526046 -0.852466697315 -18.6548206841 -63.7259526046 -0.852466697315 -18.6598206841 -63.7259526046 -0.852466697315 -18.6648206841 -63.7259526046 -0.852466697315 -18.6698206841 -63.7259526046 -0.852466697315 -18.6748206841 -63.7259526046 -0.852466697315 -18.6798206841 -63.7259526046 -0.852466697315 -18.6848206841 -63.7259526046 -0.852466697315 -18.6898206841 -63.7259526046 -0.852466697315 -18.6948206841 -63.7259526046 -0.852466697315 -18.6998206841 -63.7259526046 -0.852466697315 -18.7048206841 -63.7259526046 -0.852466697315 -18.7098206841 -63.7259526046 -0.852466697315 -18.7148206841 -63.7259526046 -0.852466697315 -18.7198206841 -63.7259526046 -0.852466697315 -18.7248206841 -63.7259526046 -0.852466697315 -18.7298206841 -63.7259526046 -0.852466697315 -18.7348206841 -63.7259526046 -0.852466697315 -18.7398206841 -63.7259526046 -0.852466697315 -18.7448206841 -63.7259526046 -0.852466697315 -18.7498206841 -63.7259526046 -0.852466697315 -18.7548206841 -63.7259526046 -0.852466697315 -18.7598206841 -63.7259526046 -0.852466697315 -18.7648206841 -63.7259526046 -0.852466697315 -18.7698206841 -63.7259526046 -0.852466697315 -18.7748206841 -63.7259526046 -0.852466697315 -18.7798206841 -63.7259526046 -0.852466697315 -18.7848206841 -63.7259526046 -0.852466697315 -18.7898206841 -63.7259526046 -0.852466697315 -18.7948206841 -63.7259526046 -0.852466697315 -18.7998206841 -63.7259526046 -0.852466697315 -18.8048206841 -63.7259526046 -0.852466697315 -18.8098206841 -63.7259526046 -0.852466697315 -18.8148206841 -63.7259526046 -0.852466697315 -18.8198206841 -63.7259526046 -0.852466697315 -18.8248206841 -63.7259526046 -0.852466697315 -18.8298206841 -63.7259526046 -0.852466697315 -18.8348206841 -63.7259526046 -0.852466697315 -18.8398206841 -63.7259526046 -0.852466697315 -18.8448206841 -63.7259526046 -0.852466697315 -18.8498206841 -63.7259526046 -0.852466697315 -18.8548206841 -63.7259526046 -0.852466697315 -18.8598206841 -63.7259526046 -0.852466697315 -18.8648206841 -63.7259526046 -0.852466697315 -18.8698206841 -63.7259526046 -0.852466697315 -18.8748206841 -63.7259526046 -0.852466697315 -18.8798206841 -63.7259526046 -0.852466697315 -18.8848206841 -63.7259526046 -0.852466697315 -18.8898206841 -63.7259526046 -0.852466697315 -18.8948206841 -63.7259526046 -0.852466697315 -18.8998206841 -63.7259526046 -0.852466697315 -18.9048206841 -63.7259526046 -0.852466697315 -18.9098206841 -63.7259526046 -0.852466697315 -18.9148206841 -63.7259526046 -0.852466697315 -18.9198206841 -63.7259526046 -0.852466697315 -18.9248206841 -63.7259526046 -0.852466697315 -18.9298206841 -63.7259526046 -0.852466697315 -18.9348206841 -63.7259526046 -0.852466697315 -18.9398206841 -63.7259526046 -0.852466697315 -18.9448206841 -63.7259526046 -0.852466697315 -18.9498206841 -63.7259526046 -0.852466697315 -18.9548206841 -63.7259526046 -0.852466697315 -18.9598206841 -63.7259526046 -0.852466697315 -18.9648206841 -63.7259526046 -0.852466697315 -18.9698206841 -63.7259526046 -0.852466697315 -18.9748206841 -63.7259526046 -0.852466697315 -18.9798206841 -63.7259526046 -0.852466697315 -18.9848206841 -63.7259526046 -0.852466697315 -18.9898206841 -63.7259526046 -0.852466697315 -18.9948206841 -63.7259526046 -0.852466697315 -18.9998206841 -63.7259526046 -0.852466697315 -19.0048206841 -63.7259526046 -0.852466697315 -19.0098206841 -63.7259526046 -0.852466697315 -19.0148206841 -63.7259526046 -0.852466697315 -19.0198206841 -63.7259526046 -0.852466697315 -19.0248206841 -63.7259526046 -0.852466697315 -19.0298206841 -63.7259526046 -0.852466697315 -19.0348206841 -63.7259526046 -0.852466697315 -19.0398206841 -63.7259526046 -0.852466697315 -19.0448206841 -63.7259526046 -0.852466697315 -19.0498206841 -63.7259526046 -0.852466697315 -19.0548206841 -63.7259526046 -0.852466697315 -19.0598206841 -63.7259526046 -0.852466697315 -19.0648206841 -63.7259526046 -0.852466697315 -19.0698206841 -63.7259526046 -0.852466697315 -19.0748206841 -63.7259526046 -0.852466697315 -19.0798206841 -63.7259526046 -0.852466697315 -19.0848206841 -63.7259526046 -0.852466697315 -19.0898206841 -63.7259526046 -0.852466697315 -19.0948206841 -63.7259526046 -0.852466697315 -19.0998206841 -63.7259526046 -0.852466697315 -19.1048206841 -63.7259526046 -0.852466697315 -19.1098206841 -63.7259526046 -0.852466697315 -19.1148206841 -63.7259526046 -0.852466697315 -19.1198206841 -63.7259526046 -0.852466697315 -19.1248206841 -63.7259526046 -0.852466697315 -19.1298206841 -63.7259526046 -0.852466697315 -19.1348206841 -63.7259526046 -0.852466697315 -19.1398206841 -63.7259526046 -0.852466697315 -19.1448206841 -63.7259526046 -0.852466697315 -19.1498206841 -63.7259526046 -0.852466697315 -19.1548206841 -63.7259526046 -0.852466697315 -19.1598206841 -63.7259526046 -0.852466697315 -19.1648206841 -63.7259526046 -0.852466697315 -19.1698206841 -63.7259526046 -0.852466697315 -19.1748206841 -63.7259526046 -0.852466697315 -19.1798206841 -63.7259526046 -0.852466697315 -19.1848206841 -63.7259526046 -0.852466697315 -19.1898206841 -63.7259526046 -0.852466697315 -19.1948206841 -63.7259526046 -0.852466697315 -19.1998206841 -63.7259526046 -0.852466697315 -19.2048206841 -63.7259526046 -0.852466697315 -19.2098206841 -63.7259526046 -0.852466697315 -19.2148206841 -63.7259526046 -0.852466697315 -19.2198206841 -63.7259526046 -0.852466697315 -19.2248206841 -63.7259526046 -0.852466697315 -19.2298206841 -63.7259526046 -0.852466697315 -19.2348206841 -63.7259526046 -0.852466697315 -19.2398206841 -63.7259526046 -0.852466697315 -19.2448206841 -63.7259526046 -0.852466697315 -19.2498206841 -63.7259526046 -0.852466697315 -19.2548206841 -63.7259526046 -0.852466697315 -19.2598206841 -63.7259526046 -0.852466697315 -19.2648206841 -63.7259526046 -0.852466697315 -19.2698206841 -63.7259526046 -0.852466697315 -19.2748206841 -63.7259526046 -0.852466697315 -19.2798206841 -63.7259526046 -0.852466697315 -19.2848206841 -63.7259526046 -0.852466697315 -19.2898206841 -63.7259526046 -0.852466697315 -19.2948206841 -63.7259526046 -0.852466697315 -19.2998206841 -63.7259526046 -0.852466697315 -19.3048206841 -63.7259526046 -0.852466697315 -19.3098206841 -63.7259526046 -0.852466697315 -19.3148206841 -63.7259526046 -0.852466697315 -19.3198206841 -63.7259526046 -0.852466697315 -19.3248206841 -63.7259526046 -0.852466697315 -19.3298206841 -63.7259526046 -0.852466697315 -19.3348206841 -63.7259526046 -0.852466697315 -19.3398206841 -63.7259526046 -0.852466697315 -19.3448206841 -63.7259526046 -0.852466697315 -19.3498206841 -63.7259526046 -0.852466697315 -19.3548206841 -63.7259526046 -0.852466697315 -19.3598206841 -63.7259526046 -0.852466697315 -19.3648206841 -63.7259526046 -0.852466697315 -19.3698206841 -63.7259526046 -0.852466697315 -19.3748206841 -63.7259526046 -0.852466697315 -19.3798206841 -63.7259526046 -0.852466697315 -19.3848206841 -63.7259526046 -0.852466697315 -19.3898206841 -63.7259526046 -0.852466697315 -19.3948206841 -63.7259526046 -0.852466697315 -19.3998206841 -63.7259526046 -0.852466697315 -19.4048206841 -63.7259526046 -0.852466697315 -19.4098206841 -63.7259526046 -0.852466697315 -19.4148206841 -63.7259526046 -0.852466697315 -19.4198206841 -63.7259526046 -0.852466697315 -19.4248206841 -63.7259526046 -0.852466697315 -19.4298206841 -63.7259526046 -0.852466697315 -19.4348206841 -63.7259526046 -0.852466697315 -19.4398206841 -63.7259526046 -0.852466697315 -19.4448206841 -63.7259526046 -0.852466697315 -19.4498206841 -63.7259526046 -0.852466697315 -19.4548206841 -63.7259526046 -0.852466697315 -19.4598206841 -63.7259526046 -0.852466697315 -19.4648206841 -63.7259526046 -0.852466697315 -19.4698206841 -63.7259526046 -0.852466697315 -19.4748206841 -63.7259526046 -0.852466697315 -19.4798206841 -63.7259526046 -0.852466697315 -19.4848206841 -63.7259526046 -0.852466697315 -19.4898206841 -63.7259526046 -0.852466697315 -19.4948206841 -63.7259526046 -0.852466697315 -19.4998206841 -63.7259526046 -0.852466697315 -19.5048206841 -63.7259526046 -0.852466697315 -19.5098206841 -63.7259526046 -0.852466697315 -19.5148206841 -63.7259526046 -0.852466697315 -19.5198206841 -63.7259526046 -0.852466697315 -19.5248206841 -63.7259526046 -0.852466697315 -19.5298206841 -63.7259526046 -0.852466697315 -19.5348206841 -63.7259526046 -0.852466697315 -19.5398206841 -63.7259526046 -0.852466697315 -19.5448206841 -63.7259526046 -0.852466697315 -19.5498206841 -63.7259526046 -0.852466697315 -19.5548206841 463.526082386 -0.852466697315 -19.5598206841 546.806932405 -0.852466697315 -19.5648206841 494.469888701 -0.852466697315 -19.5698206841 1098.33808661 -0.852466697315 -19.5748206841 1577.82834352 -0.852466697315 -19.5798206841 2052.60438664 -0.852466697315 -19.5848206841 2108.63801497 -0.852466697315 -19.5898206841 2224.69912227 -0.852466697315 -19.5948206841 1873.18357215 -0.852466697315 -19.5998206841 1729.45730607 -0.852466697315 -19.6048206841 1482.68115057 -0.852466697315 -19.6098206841 1238.91675669 -0.852466697315 -19.6148206841 989.052766341 -0.852466697315 -19.6198206841 777.647971445 -0.852466697315 -19.6248206841 580.224717776 -0.852466697315 -19.6298206841 425.575206425 -0.852466697315 -19.6348206841 332.185812298 -0.852466697315 -19.6398206841 284.187452702 -0.852466697315 -19.6448206841 261.336385395 -0.852466697315 -19.6498206841 275.929698365 -0.852466697315 -19.6548206841 309.84118536 -0.852466697315 -19.6598206841 362.090030654 -0.852466697315 -19.6648206841 415.22778505 -0.852466697315 -19.6698206841 469.862686556 -0.852466697315 -19.6748206841 521.477986636 -0.852466697315 -19.6798206841 560.228919025 -0.852466697315 -19.6848206841 582.686191529 -0.852466697315 -19.6898206841 595.538598957 -0.852466697315 -19.6948206841 591.63549328 -0.852466697315 -19.6998206841 585.817876062 -0.852466697315 -19.7048206841 567.060502226 -0.852466697315 -19.7098206841 542.590903508 -0.852466697315 -19.7148206841 523.473081644 -0.852466697315 -19.7198206841 507.365090279 -0.852466697315 -19.7248206841 500.050351007 -0.852466697315 -19.7298206841 492.584466646 -0.852466697315 -19.7348206841 492.438590987 -0.852466697315 -19.7398206841 495.48404121 -0.852466697315 -19.7448206841 500.842927906 -0.852466697315 -19.7498206841 503.11022304 -0.852466697315 -19.7548206841 511.125069389 -0.852466697315 -19.7598206841 521.93742407 -0.852466697315 -19.7648206841 530.022550583 -0.852466697315 -19.7698206841 543.247373447 -0.852466697315 -19.7748206841 556.926720186 -0.852466697315 -19.7798206841 567.614686896 -0.852466697315 -19.7848206841 574.288767221 -0.852466697315 -19.7898206841 583.474323917 -0.852466697315 -19.7948206841 596.019756215 -0.852466697315 -19.7998206841 601.319875073 -0.852466697315 -19.8048206841 608.096333156 -0.852466697315 -19.8098206841 613.593693942 -0.852466697315 -19.8148206841 616.189030734 -0.852466697315 -19.8198206841 625.315403175 -0.852466697315 -19.8248206841 629.466232211 -0.852466697315 -19.8298206841 636.009727864 -0.852466697315 -19.8348206841 639.305377756 -0.852466697315 -19.8398206841 647.215482836 -0.852466697315 -19.8448206841 586.700930202 -0.852466697315 -19.8498206841 626.331579148 -0.852466697315 -19.8548206841 644.294232163 -0.852466697315 -19.8598206841 662.870632215 -0.852466697315 -19.8648206841 682.573307448 -0.852466697315 -19.8698206841 702.694938047 -0.852466697315 -19.8748206841 720.086435567 -0.852466697315 -19.8798206841 738.74392683 -0.852466697315 -19.8848206841 766.665300681 -0.852466697315 -19.8898206841 792.970728272 -0.852466697315 -19.8948206841 813.116218364 -0.852466697315 -19.8998206841 837.494859869 -0.852466697315 -19.9048206841 844.219978556 -0.852466697315 -19.9098206841 863.268214334 -0.852466697315 -19.9148206841 872.227318301 -0.852466697315 -19.9198206841 880.528759114 -0.852466697315 -19.9248206841 878.651219225 -0.852466697315 -19.9298206841 873.613279738 -0.852466697315 -19.9348206841 867.562893675 -0.852466697315 -19.9398206841 869.623466652 -0.852466697315 -19.9448206841 867.681222052 -0.852466697315 -19.9498206841 813.264560259 -0.852466697315 -19.9548206841 782.595890994 -0.852466697315 -19.9598206841 738.129191513 -0.852466697315 -19.9648206841 724.216968516 -0.852466697315 -19.9698206841 674.989240462 -0.852466697315 -19.9748206841 633.318357911 -0.852466697315 -19.9798206841 617.390217123 -0.852466697315 -19.9848206841 557.004364983 -0.852466697315 -19.9898206841 537.754324685 -0.852466697315 -19.9948206841 498.332764276 -0.852466697315 -19.9998206841 454.129009901 -0.852466697315 -20.0048206841 415.972069648 -0.852466697315 -20.0098206841 381.570568482 -0.852466697315 -20.0148206841 410.304572796 -0.852466697315 -20.0198206841 432.06998672 -0.852466697315 -20.0248206841 433.705368818 -0.852466697315 -20.0298206841 585.255959469 -0.852466697315 -20.0348206841 559.605562266 -0.852466697315 -20.0398206841 562.202917844 -0.852466697315 -20.0448206841 542.246843384 -0.852466697315 -20.0498206841 539.41772051 -0.852466697315 -20.0548206841 524.753039361 -0.852466697315 -20.0598206841 557.22581709 -0.852466697315 -20.0648206841 522.837903583 -0.852466697315 -20.0698206841 477.555313045 -0.852466697315 -20.0748206841 457.864223519 -0.852466697315 -20.0798206841 443.424692372 -0.852466697315 -20.0848206841 433.828830205 -0.852466697315 -20.0898206841 412.406137791 -0.852466697315 -20.0948206841 419.372537985 -0.852466697315 -20.0998206841 443.092505666 -0.852466697315 -20.1048206841 428.286712401 -0.852466697315 -20.1098206841 414.908389856 -0.852466697315 -20.1148206841 406.183112843 -0.852466697315 -20.1198206841 394.145751962 -0.852466697315 -20.1248206841 376.376654898 -0.852466697315 -20.1298206841 360.913203351 -0.852466697315 -20.1348206841 350.950374739 -0.852466697315 -20.1398206841 334.340738377 -0.852466697315 -20.1448206841 325.369827931 -0.852466697315 -20.1498206841 320.028399432 -0.852466697315 -20.1548206841 313.973209908 -0.852466697315 -20.1598206841 318.375295575 -0.852466697315 -20.1648206841 326.325884599 -0.852466697315 -20.1698206841 330.228412875 -0.852466697315 -20.1748206841 337.460075608 -0.852466697315 -20.1798206841 349.215025896 -0.852466697315 -20.1848206841 354.742456978 -0.852466697315 -20.1898206841 356.090071195 -0.852466697315 -20.1948206841 362.067826209 -0.852466697315 -20.1998206841 363.49510937 -0.852466697315 -20.2048206841 362.710190789 -0.852466697315 -20.2098206841 362.971489563 -0.852466697315 -20.2148206841 366.877189439 -0.852466697315 -20.2198206841 369.496122824 -0.852466697315 -20.2248206841 374.600159697 -0.852466697315 -20.2298206841 380.623497259 -0.852466697315 -20.2348206841 386.345353718 -0.852466697315 -20.2398206841 382.644221985 -0.852466697315 -20.2448206841 378.543491384 -0.852466697315 -20.2498206841 371.451550039 -0.852466697315 -20.2548206841 389.388672303 -0.852466697315 -20.2598206841 370.813286187 -0.852466697315 -20.2648206841 347.275274172 -0.852466697315 -20.2698206841 329.860715067 -0.852466697315 -20.2748206841 312.277895681 -0.852466697315 -20.2798206841 296.075602056 -0.852466697315 -20.2848206841 282.385551336 -0.852466697315 -20.2898206841 269.474395442 -0.852466697315 -20.2948206841 261.467211229 -0.852466697315 -20.2998206841 254.408093812 -0.852466697315 -20.3048206841 247.85811258 -0.852466697315 -20.3098206841 243.279197654 -0.852466697315 -20.3148206841 240.367758962 -0.852466697315 -20.3198206841 239.787976398 -0.852466697315 -20.3248206841 239.461009149 -0.852466697315 -20.3298206841 239.269101221 -0.852466697315 -20.3348206841 240.649722986 -0.852466697315 -20.3398206841 244.707004881 -0.852466697315 -20.3448206841 240.182944625 -0.852466697315 -20.3498206841 230.837341807 -0.852466697315 -20.3548206841 223.962076891 -0.852466697315 -20.3598206841 216.489022446 -0.852466697315 -20.3648206841 201.363132766 -0.852466697315 -20.3698206841 195.429932585 -0.852466697315 -20.3748206841 187.831109014 -0.852466697315 -20.3798206841 182.900686562 -0.852466697315 -20.3848206841 177.890119445 -0.852466697315 -20.3898206841 167.910770569 -0.852466697315 -20.3948206841 150.856487101 -0.852466697315 -20.3998206841 139.273664832 -0.852466697315 -20.4048206841 130.477310511 -0.852466697315 -20.4098206841 113.877004649 -0.852466697315 -20.4148206841 97.9100351681 -0.852466697315 -20.4198206841 83.767069466 -0.852466697315 -20.4248206841 72.6509568198 -0.852466697315 -20.4298206841 58.4296278893 -0.852466697315 -20.4348206841 51.9211742542 -0.852466697315 -20.4398206841 44.3639873277 -0.852466697315 -20.4448206841 39.5894298278 -0.852466697315 -20.4498206841 25.1799564525 -0.852466697315 -20.4548206841 21.7644807721 -0.852466697315 -20.4598206841 28.7549622922 -0.852466697315 -20.4648206841 18.103024761 -0.852466697315 -20.4698206841 7.14540897556 -0.852466697315 -20.4748206841 0.633927300239 -0.852466697315 -20.4798206841 -7.72686604159 -0.852466697315 -20.4848206841 -14.4227948672 -0.852466697315 -20.4898206841 -22.1516967823 -0.852466697315 -20.4948206841 -33.7664297466 -0.852466697315 -20.4998206841 -44.113934992 -0.852466697315 -20.5048206841 -55.2532330119 -0.852466697315 -20.5098206841 -68.7040565764 -0.852466697315 -20.5148206841 -59.6097264699 -0.852466697315 -20.5198206841 -59.6097264699 -0.852466697315 -20.5248206841 -59.6097264699 -0.852466697315 -20.5298206841 -59.6097264699 -0.852466697315 -20.5348206841 -59.6097264699 -0.852466697315 -20.5398206841 -59.6097264699 -0.852466697315 -20.5448206841 -59.6097264699 -0.852466697315 -20.5498206841 -59.6097264699 -0.852466697315 -20.5548206841 -59.6097264699 -0.852466697315 -20.5598206841 -59.6097264699 -0.852466697315 -20.5648206841 -59.6097264699 -0.852466697315 -20.5698206841 -59.6097264699 -0.852466697315 -20.5748206841 -59.6097264699 -0.852466697315 -20.5798206841 -59.6097264699 -0.852466697315 -20.5848206841 -59.6097264699 -0.852466697315 -20.5898206841 -59.6097264699 -0.852466697315 -20.5948206841 -59.6097264699 -0.852466697315 -20.5998206841 -59.6097264699 -0.852466697315 -20.6048206841 -59.6097264699 -0.852466697315 -20.6098206841 -59.6097264699 -0.852466697315 -20.6148206841 -59.6097264699 -0.852466697315 -20.6198206841 -59.6097264699 -0.852466697315 -20.6248206841 -59.6097264699 -0.852466697315 -20.6298206841 -59.6097264699 -0.852466697315 -20.6348206841 -59.6097264699 -0.852466697315 -20.6398206841 -59.6097264699 -0.852466697315 -20.6448206841 -59.6097264699 -0.852466697315 -20.6498206841 -59.6097264699 -0.852466697315 -20.6548206841 -59.6097264699 -0.852466697315 -20.6598206841 -59.6097264699 -0.852466697315 -20.6648206841 -59.6097264699 -0.852466697315 -20.6698206841 -59.6097264699 -0.852466697315 -20.6748206841 -59.6097264699 -0.852466697315 -20.6798206841 -59.6097264699 -0.852466697315 -20.6848206841 -59.6097264699 -0.852466697315 -20.6898206841 -59.6097264699 -0.852466697315 -20.6948206841 -59.6097264699 -0.852466697315 -20.6998206841 -59.6097264699 -0.852466697315 -20.7048206841 -59.6097264699 -0.852466697315 -20.7098206841 -59.6097264699 -0.852466697315 -20.7148206841 -59.6097264699 -0.852466697315 -20.7198206841 -59.6097264699 -0.852466697315 -20.7248206841 -59.6097264699 -0.852466697315 -20.7298206841 -59.6097264699 -0.852466697315 -20.7348206841 -59.6097264699 -0.852466697315 -20.7398206841 -59.6097264699 -0.852466697315 -20.7448206841 -59.6097264699 -0.852466697315 -20.7498206841 -59.6097264699 -0.852466697315 -20.7548206841 -59.6097264699 -0.852466697315 -20.7598206841 -59.6097264699 -0.852466697315 -20.7648206841 -59.6097264699 -0.852466697315 -20.7698206841 -59.6097264699 -0.852466697315 -20.7748206841 -59.6097264699 -0.852466697315 -20.7798206841 -59.6097264699 -0.852466697315 -20.7848206841 -59.6097264699 -0.852466697315 -20.7898206841 -59.6097264699 -0.852466697315 -20.7948206841 -59.6097264699 -0.852466697315 -20.7998206841 -59.6097264699 -0.852466697315 -20.8048206841 -59.6097264699 -0.852466697315 -20.8098206841 -59.6097264699 -0.852466697315 -20.8148206841 -59.6097264699 -0.852466697315 -20.8198206841 -59.6097264699 -0.852466697315 -20.8248206841 -59.6097264699 -0.852466697315 -20.8298206841 -59.6097264699 -0.852466697315 -20.8348206841 -59.6097264699 -0.852466697315 -20.8398206841 -59.6097264699 -0.852466697315 -20.8448206841 -59.6097264699 -0.852466697315 -20.8498206841 -59.6097264699 -0.852466697315 -20.8548206841 -59.6097264699 -0.852466697315 -20.8598206841 -59.6097264699 -0.852466697315 -20.8648206841 -59.6097264699 -0.852466697315 -20.8698206841 -59.6097264699 -0.852466697315 -20.8748206841 -59.6097264699 -0.852466697315 -20.8798206841 -59.6097264699 -0.852466697315 -20.8848206841 -59.6097264699 -0.852466697315 -20.8898206841 -59.6097264699 -0.852466697315 -20.8948206841 -59.6097264699 -0.852466697315 -20.8998206841 -59.6097264699 -0.852466697315 -20.9048206841 -59.6097264699 -0.852466697315 -20.9098206841 -59.6097264699 -0.852466697315 -20.9148206841 -59.6097264699 -0.852466697315 -20.9198206841 -59.6097264699 -0.852466697315 -20.9248206841 -59.6097264699 -0.852466697315 -20.9298206841 -59.6097264699 -0.852466697315 -20.9348206841 -59.6097264699 -0.852466697315 -20.9398206841 -59.6097264699 -0.852466697315 -20.9448206841 -59.6097264699 -0.852466697315 -20.9498206841 -59.6097264699 -0.852466697315 -20.9548206841 -59.6097264699 -0.852466697315 -20.9598206841 -59.6097264699 -0.852466697315 -20.9648206841 -59.6097264699 -0.852466697315 -20.9698206841 -59.6097264699 -0.852466697315 -20.9748206841 -59.6097264699 -0.852466697315 -20.9798206841 -59.6097264699 -0.852466697315 -20.9848206841 -59.6097264699 -0.852466697315 -20.9898206841 -59.6097264699 -0.852466697315 -20.9948206841 -59.6097264699 -0.852466697315 -20.9998206841 -59.6097264699 -0.852466697315 -21.0048206841 -59.6097264699 -0.852466697315 -21.0098206841 -59.6097264699 -0.852466697315 -21.0148206841 -59.6097264699 -0.852466697315 -21.0198206841 -59.6097264699 -0.852466697315 -21.0248206841 -59.6097264699 -0.852466697315 -21.0298206841 -59.6097264699 -0.852466697315 -21.0348206841 -59.6097264699 -0.852466697315 -21.0398206841 -59.6097264699 -0.852466697315 -21.0448206841 -59.6097264699 -0.852466697315 -21.0498206841 -59.6097264699 -0.852466697315 -21.0548206841 -59.6097264699 -0.852466697315 -21.0598206841 -59.6097264699 -0.852466697315 -21.0648206841 -59.6097264699 -0.852466697315 -21.0698206841 -59.6097264699 -0.852466697315 -21.0748206841 -59.6097264699 -0.852466697315 -21.0798206841 -59.6097264699 -0.852466697315 -21.0848206841 -59.6097264699 -0.852466697315 -21.0898206841 -59.6097264699 -0.852466697315 -21.0948206841 -59.6097264699 -0.852466697315 -21.0998206841 -59.6097264699 -0.852466697315 -21.1048206841 -59.6097264699 -0.852466697315 -21.1098206841 -59.6097264699 -0.852466697315 -21.1148206841 -59.6097264699 -0.852466697315 -21.1198206841 -59.6097264699 -0.852466697315 -21.1248206841 -59.6097264699 -0.852466697315 -21.1298206841 -59.6097264699 -0.852466697315 -21.1348206841 -59.6097264699 -0.852466697315 -21.1398206841 -59.6097264699 -0.852466697315 -21.1448206841 -59.6097264699 -0.852466697315 -21.1498206841 -59.6097264699 -0.852466697315 -21.1548206841 -59.6097264699 -0.852466697315 -21.1598206841 -59.6097264699 -0.852466697315 -21.1648206841 -59.6097264699 -0.852466697315 -21.1698206841 -59.6097264699 -0.852466697315 -21.1748206841 -59.6097264699 -0.852466697315 -21.1798206841 -59.6097264699 -0.852466697315 -21.1848206841 -59.6097264699 -0.852466697315 -21.1898206841 -59.6097264699 -0.852466697315 -21.1948206841 -59.6097264699 -0.852466697315 -21.1998206841 -59.6097264699 -0.852466697315 -21.2048206841 -59.6097264699 -0.852466697315 -21.2098206841 -59.6097264699 -0.852466697315 -21.2148206841 -59.6097264699 -0.852466697315 -21.2198206841 -59.6097264699 -0.852466697315 -21.2248206841 -59.6097264699 -0.852466697315 -21.2298206841 -59.6097264699 -0.852466697315 -21.2348206841 -59.6097264699 -0.852466697315 -21.2398206841 -59.6097264699 -0.852466697315 -21.2448206841 -59.6097264699 -0.852466697315 -21.2498206841 -59.6097264699 -0.852466697315 -21.2548206841 -59.6097264699 -0.852466697315 -21.2598206841 -59.6097264699 -0.852466697315 -21.2648206841 -59.6097264699 -0.852466697315 -21.2698206841 -59.6097264699 -0.852466697315 -21.2748206841 -59.6097264699 -0.852466697315 -21.2798206841 -59.6097264699 -0.852466697315 -21.2848206841 -59.6097264699 -0.852466697315 -21.2898206841 -59.6097264699 -0.852466697315 -21.2948206841 -59.6097264699 -0.852466697315 -21.2998206841 -59.6097264699 -0.852466697315 -21.3048206841 -59.6097264699 -0.852466697315 -21.3098206841 -59.6097264699 -0.852466697315 -21.3148206841 -59.6097264699 -0.852466697315 -21.3198206841 -59.6097264699 -0.852466697315 -21.3248206841 -59.6097264699 -0.852466697315 -21.3298206841 -59.6097264699 -0.852466697315 -21.3348206841 -59.6097264699 -0.852466697315 -21.3398206841 -59.6097264699 -0.852466697315 -21.3448206841 -59.6097264699 -0.852466697315 -21.3498206841 -59.6097264699 -0.852466697315 -21.3548206841 -59.6097264699 -0.852466697315 -21.3598206841 -59.6097264699 -0.852466697315 -21.3648206841 -59.6097264699 -0.852466697315 -21.3698206841 -59.6097264699 -0.852466697315 -21.3748206841 -59.6097264699 -0.852466697315 -21.3798206841 -59.6097264699 -0.852466697315 -21.3848206841 -59.6097264699 -0.852466697315 -21.3898206841 -59.6097264699 -0.852466697315 -21.3948206841 -59.6097264699 3.95955533803 -21.3998206841 -59.6097264699 3.91786525088 -21.4048206841 -59.6097264699 3.91786525088 -21.4098206841 -59.6097264699 3.91786525088 -21.4148206841 -59.6097264699 3.91786525088 -21.4198206841 -59.6097264699 3.91786525088 -21.4248206841 -59.6097264699 3.91786525088 -21.4298206841 -59.6097264699 3.91786525088 -21.4348206841 -59.6097264699 3.91786525088 -21.4398206841 -59.6097264699 3.91786525088 -21.4448206841 -59.6097264699 3.91786525088 -21.4498206841 -59.6097264699 3.91786525088 -21.4548206841 -59.6097264699 3.91786525088 -21.4598206841 -59.6097264699 3.91786525088 -21.4648206841 -59.6097264699 3.91786525088 -21.4698206841 -59.6097264699 3.91786525088 -21.4748206841 -59.6097264699 3.91786525088 -21.4798206841 844.986818547 3.91786525088 -21.4848206841 1277.79472489 3.91786525088 -21.4898206841 1404.37171949 3.91786525088 -21.4948206841 1681.65349474 3.91786525088 -21.4998206841 1757.88341814 3.91786525088 -21.5048206841 1752.617756 3.91786525088 -21.5098206841 1705.28174308 3.91786525088 -21.5148206841 1506.25740919 3.91786525088 -21.5198206841 1335.34565056 3.91786525088 -21.5248206841 1191.48931498 3.91786525088 -21.5298206841 1054.0381618 3.91786525088 -21.5348206841 875.938039443 3.91786525088 -21.5398206841 728.600421756 3.91786525088 -21.5448206841 588.407108674 3.91786525088 -21.5498206841 486.566295179 3.91786525088 -21.5548206841 409.474180481 3.91786525088 -21.5598206841 357.545452391 3.91786525088 -21.5648206841 344.215899199 3.91786525088 -21.5698206841 354.082614692 3.91786525088 -21.5748206841 381.576978427 3.52002276304 -21.5798206841 419.771795621 3.56776039227 -21.5848206841 466.271378615 3.56776039227 -21.5898206841 505.4300366 3.56776039227 -21.5948206841 544.240468909 3.56776039227 -21.5998206841 573.383685319 3.56776039227 -21.6048206841 594.79983304 3.56776039227 -21.6098206841 603.806040927 3.56776039227 -21.6148206841 601.259069307 3.56776039227 -21.6198206841 591.228780117 3.56776039227 -21.6248206841 573.767338241 3.56776039227 -21.6298206841 553.082628018 3.56776039227 -21.6348206841 532.064852025 3.56776039227 -21.6398206841 510.264694925 3.56776039227 -21.6448206841 497.372866074 3.56776039227 -21.6498206841 486.659956241 3.56776039227 -21.6548206841 477.932128545 3.56776039227 -21.6598206841 474.094576901 3.56776039227 -21.6648206841 473.925437425 3.56776039227 -21.6698206841 480.118809081 3.56776039227 -21.6748206841 486.493278631 3.56776039227 -21.6798206841 500.403605756 3.56776039227 -21.6848206841 510.948297009 3.56776039227 -21.6898206841 523.680410541 3.56776039227 -21.6948206841 537.740641225 3.56776039227 -21.6998206841 550.581817711 3.56776039227 -21.7048206841 562.48526363 3.56776039227 -21.7098206841 572.331147463 3.56776039227 -21.7148206841 583.382667556 3.56776039227 -21.7198206841 593.785662723 3.56776039227 -21.7248206841 598.956754949 3.56776039227 -21.7298206841 606.907417416 3.56776039227 -21.7348206841 615.878618655 3.56776039227 -21.7398206841 621.238181143 3.56776039227 -21.7448206841 626.531307746 3.56776039227 -21.7498206841 633.921209697 3.56776039227 -21.7548206841 643.245596755 3.56776039227 -21.7598206841 652.253249827 3.56776039227 -21.7648206841 661.074584578 3.56776039227 -21.7698206841 680.591049865 3.56776039227 -21.7748206841 700.596679313 3.56776039227 -21.7798206841 723.731918561 3.56776039227 -21.7848206841 751.697204639 3.56776039227 -21.7898206841 782.702150441 3.56776039227 -21.7948206841 808.311674567 3.56776039227 -21.7998206841 842.620098913 3.56776039227 -21.8048206841 875.332907051 3.56776039227 -21.8098206841 892.208809707 3.56776039227 -21.8148206841 915.539445798 3.56776039227 -21.8198206841 954.492375334 3.56776039227 -21.8248206841 949.502745605 3.56776039227 -21.8298206841 986.08238449 3.56776039227 -21.8348206841 934.995232433 3.56776039227 -21.8398206841 957.745608664 3.56776039227 -21.8448206841 890.623562357 3.56776039227 -21.8498206841 866.423257212 3.56776039227 -21.8548206841 860.561618703 3.56776039227 -21.8598206841 811.697488594 3.56776039227 -21.8648206841 789.656459005 3.56776039227 -21.8698206841 763.284080953 3.56776039227 -21.8748206841 725.350061134 3.56776039227 -21.8798206841 642.18177502 3.56776039227 -21.8848206841 598.203126908 3.56776039227 -21.8898206841 552.245003824 3.56776039227 -21.8948206841 518.692012801 3.56776039227 -21.8998206841 480.443324128 3.56776039227 -21.9048206841 448.039955407 3.56776039227 -21.9098206841 434.368423113 3.56776039227 -21.9148206841 393.965749464 3.56776039227 -21.9198206841 377.950182983 3.56776039227 -21.9248206841 362.325988742 3.56776039227 -21.9298206841 360.625529442 3.56776039227 -21.9348206841 357.828854144 3.56776039227 -21.9398206841 355.467950218 3.56776039227 -21.9448206841 353.1255529 3.56776039227 -21.9498206841 336.289623014 3.56776039227 -21.9548206841 322.576850666 3.56776039227 -21.9598206841 311.034264511 3.56776039227 -21.9648206841 310.222656422 3.56776039227 -21.9698206841 287.395834879 3.56776039227 -21.9748206841 304.71804173 3.56776039227 -21.9798206841 293.039727663 3.56776039227 -21.9848206841 304.367040458 3.56776039227 -21.9898206841 269.431976099 3.56776039227 -21.9948206841 351.303007492 3.56776039227 -21.9998206841 305.957901177 3.56776039227 -22.0048206841 314.64620433 3.56776039227 -22.0098206841 331.063590977 3.56776039227 -22.0148206841 346.866611418 3.56776039227 -22.0198206841 286.007632934 3.56776039227 -22.0248206841 257.367277301 3.56776039227 -22.0298206841 236.048055256 3.56776039227 -22.0348206841 227.701656654 3.56776039227 -22.0398206841 214.239836953 3.56776039227 -22.0448206841 208.464829727 3.56776039227 -22.0498206841 196.54467675 3.56776039227 -22.0548206841 186.931103331 3.56776039227 -22.0598206841 184.88306318 3.56776039227 -22.0648206841 184.958448691 3.56776039227 -22.0698206841 180.261637235 3.56776039227 -22.0748206841 184.499273785 3.56776039227 -22.0798206841 197.787489421 3.56776039227 -22.0848206841 270.381935943 3.56776039227 -22.0898206841 289.209726763 3.56776039227 -22.0948206841 311.587830155 3.56776039227 -22.0998206841 316.224778745 3.56776039227 -22.1048206841 322.606976861 3.56776039227 -22.1098206841 333.797324507 3.56776039227 -22.1148206841 355.264158302 3.56776039227 -22.1198206841 381.222213392 3.56776039227 -22.1248206841 395.142061271 3.56776039227 -22.1298206841 391.3303073 3.56776039227 -22.1348206841 392.03484518 3.56776039227 -22.1398206841 388.427527577 3.56776039227 -22.1448206841 382.135191287 3.56776039227 -22.1498206841 372.65531659 3.56776039227 -22.1548206841 365.285921391 3.56776039227 -22.1598206841 354.504435185 3.56776039227 -22.1648206841 351.21531227 3.56776039227 -22.1698206841 334.475313393 3.56776039227 -22.1748206841 309.261154867 3.56776039227 -22.1798206841 302.111015928 3.56776039227 -22.1848206841 284.856411638 3.56776039227 -22.1898206841 270.721452485 3.56776039227 -22.1948206841 264.099056086 3.56776039227 -22.1998206841 252.347964877 3.56776039227 -22.2048206841 244.393463469 3.56776039227 -22.2098206841 245.23673458 3.56776039227 -22.2148206841 238.709109895 3.56776039227 -22.2198206841 238.803785682 3.56776039227 -22.2248206841 241.163982819 3.56776039227 -22.2298206841 237.614908544 3.56776039227 -22.2348206841 239.646947356 3.56776039227 -22.2398206841 246.682773778 3.56776039227 -22.2448206841 251.59554338 3.56776039227 -22.2498206841 256.464875002 3.56776039227 -22.2548206841 259.788827095 3.56776039227 -22.2598206841 264.858814719 3.56776039227 -22.2648206841 267.909380995 3.56776039227 -22.2698206841 266.378087247 3.56776039227 -22.2748206841 258.95826676 3.56776039227 -22.2798206841 252.536879086 3.56776039227 -22.2848206841 241.091842576 3.56776039227 -22.2898206841 230.196306464 3.56776039227 -22.2948206841 220.122483847 3.56776039227 -22.2998206841 210.135652171 3.56776039227 -22.3048206841 194.4918046 3.56776039227 -22.3098206841 179.283128908 3.56776039227 -22.3148206841 167.98544049 3.56776039227 -22.3198206841 143.345443231 3.56776039227 -22.3248206841 126.067688896 3.56776039227 -22.3298206841 117.606914104 3.56776039227 -22.3348206841 117.978950885 3.56776039227 -22.3398206841 109.011766292 3.56776039227 -22.3448206841 102.791374556 3.56776039227 -22.3498206841 94.1526260364 3.56776039227 -22.3548206841 81.2652398836 3.56776039227 -22.3598206841 72.8209146138 3.56776039227 -22.3648206841 65.1433199445 3.56776039227 -22.3698206841 55.5029209599 3.56776039227 -22.3748206841 49.990562322 3.56776039227 -22.3798206841 44.2825769937 3.56776039227 -22.3848206841 38.2568490339 3.56776039227 -22.3898206841 33.033800353 3.56776039227 -22.3948206841 30.6561124377 3.56776039227 -22.3998206841 26.3408181656 3.56776039227 -22.4048206841 19.4330641113 3.56776039227 -22.4098206841 13.9062432183 3.56776039227 -22.4148206841 -0.838412990158 3.56776039227 -22.4198206841 -12.6794457071 3.56776039227 -22.4248206841 -22.2424711029 3.56776039227 -22.4298206841 -29.1069252675 3.56776039227 -22.4348206841 -34.9258157476 3.56776039227 -22.4398206841 -39.3501486476 3.56776039227 -22.4448206841 -38.3091918089 3.56776039227 -22.4498206841 -38.443214352 3.56776039227 -22.4548206841 -20.9902993754 3.56776039227 -22.4598206841 -70.0536414024 3.56776039227 -22.4648206841 -27.0287132609 3.56776039227 -22.4698206841 -67.0604119056 3.56776039227 -22.4748206841 -67.0604119056 3.56776039227 -22.4798206841 -67.0604119056 3.56776039227 -22.4848206841 -67.0604119056 3.56776039227 -22.4898206841 -67.0604119056 3.56776039227 -22.4948206841 -67.0604119056 3.56776039227 -22.4998206841 -67.0604119056 3.56776039227 -22.5048206841 -67.0604119056 3.56776039227 -22.5098206841 -67.0604119056 3.56776039227 -22.5148206841 -67.0604119056 3.56776039227 -22.5198206841 -67.0604119056 3.56776039227 -22.5248206841 -67.0604119056 3.56776039227 -22.5298206841 -67.0604119056 3.56776039227 -22.5348206841 -67.0604119056 3.56776039227 -22.5398206841 -67.0604119056 3.56776039227 -22.5448206841 -67.0604119056 3.56776039227 -22.5498206841 -67.0604119056 3.56776039227 -22.5548206841 -67.0604119056 3.56776039227 -22.5598206841 -67.0604119056 3.56776039227 -22.5648206841 -67.0604119056 3.56776039227 -22.5698206841 -67.0604119056 3.56776039227 -22.5748206841 -67.0604119056 3.56776039227 -22.5798206841 -67.0604119056 3.56776039227 -22.5848206841 -67.0604119056 3.56776039227 -22.5898206841 -67.0604119056 3.56776039227 -22.5948206841 -67.0604119056 3.56776039227 -22.5998206841 -67.0604119056 3.56776039227 -22.6048206841 -67.0604119056 3.56776039227 -22.6098206841 -67.0604119056 3.56776039227 -22.6148206841 -67.0604119056 3.56776039227 -22.6198206841 -67.0604119056 3.56776039227 -22.6248206841 -67.0604119056 3.56776039227 -22.6298206841 -67.0604119056 3.56776039227 -22.6348206841 -67.0604119056 3.56776039227 -22.6398206841 -67.0604119056 3.56776039227 -22.6448206841 -67.0604119056 3.56776039227 -22.6498206841 -67.0604119056 3.56776039227 -22.6548206841 -67.0604119056 3.56776039227 -22.6598206841 -67.0604119056 3.56776039227 -22.6648206841 -67.0604119056 3.56776039227 -22.6698206841 -67.0604119056 3.56776039227 -22.6748206841 -67.0604119056 3.56776039227 -22.6798206841 -67.0604119056 3.56776039227 -22.6848206841 -67.0604119056 3.56776039227 -22.6898206841 -67.0604119056 3.56776039227 -22.6948206841 -67.0604119056 3.56776039227 -22.6998206841 -67.0604119056 3.56776039227 -22.7048206841 -67.0604119056 3.56776039227 -22.7098206841 -67.0604119056 3.56776039227 -22.7148206841 -67.0604119056 3.56776039227 -22.7198206841 -67.0604119056 3.56776039227 -22.7248206841 -67.0604119056 3.56776039227 -22.7298206841 -67.0604119056 3.56776039227 -22.7348206841 -67.0604119056 3.56776039227 -22.7398206841 -67.0604119056 3.56776039227 -22.7448206841 -67.0604119056 3.56776039227 -22.7498206841 -67.0604119056 3.56776039227 -22.7548206841 -67.0604119056 3.56776039227 -22.7598206841 -67.0604119056 3.56776039227 -22.7648206841 -67.0604119056 3.56776039227 -22.7698206841 -67.0604119056 3.56776039227 -22.7748206841 -67.0604119056 3.56776039227 -22.7798206841 -67.0604119056 3.56776039227 -22.7848206841 -67.0604119056 3.56776039227 -22.7898206841 -67.0604119056 3.56776039227 -22.7948206841 -67.0604119056 3.56776039227 -22.7998206841 -67.0604119056 3.56776039227 -22.8048206841 -67.0604119056 3.56776039227 -22.8098206841 -67.0604119056 3.56776039227 -22.8148206841 -67.0604119056 3.56776039227 -22.8198206841 -67.0604119056 3.56776039227 -22.8248206841 -67.0604119056 3.56776039227 -22.8298206841 -67.0604119056 3.56776039227 -22.8348206841 -67.0604119056 3.56776039227 -22.8398206841 -67.0604119056 3.56776039227 -22.8448206841 -67.0604119056 3.56776039227 -22.8498206841 -67.0604119056 3.56776039227 -22.8548206841 -67.0604119056 3.56776039227 -22.8598206841 -67.0604119056 3.56776039227 -22.8648206841 -67.0604119056 3.56776039227 -22.8698206841 -67.0604119056 3.56776039227 -22.8748206841 -67.0604119056 3.56776039227 -22.8798206841 -67.0604119056 3.56776039227 -22.8848206841 -67.0604119056 3.56776039227 -22.8898206841 -67.0604119056 3.56776039227 -22.8948206841 -67.0604119056 3.56776039227 -22.8998206841 -67.0604119056 3.56776039227 -22.9048206841 -67.0604119056 3.56776039227 -22.9098206841 -67.0604119056 3.56776039227 -22.9148206841 -67.0604119056 3.56776039227 -22.9198206841 -67.0604119056 3.56776039227 -22.9248206841 -67.0604119056 3.56776039227 -22.9298206841 -67.0604119056 3.56776039227 -22.9348206841 -67.0604119056 3.56776039227 -22.9398206841 -67.0604119056 3.56776039227 -22.9448206841 -67.0604119056 3.56776039227 -22.9498206841 -67.0604119056 3.56776039227 -22.9548206841 -67.0604119056 3.56776039227 -22.9598206841 -67.0604119056 3.56776039227 -22.9648206841 -67.0604119056 3.56776039227 -22.9698206841 -67.0604119056 3.56776039227 -22.9748206841 -67.0604119056 3.56776039227 -22.9798206841 -67.0604119056 3.56776039227 -22.9848206841 -67.0604119056 3.56776039227 -22.9898206841 -67.0604119056 3.56776039227 -22.9948206841 -67.0604119056 3.56776039227 -22.9998206841 -67.0604119056 3.56776039227 -23.0048206841 -67.0604119056 3.56776039227 -23.0098206841 -67.0604119056 3.56776039227 -23.0148206841 -67.0604119056 3.56776039227 -23.0198206841 -67.0604119056 3.56776039227 -23.0248206841 -67.0604119056 3.56776039227 -23.0298206841 -67.0604119056 3.56776039227 -23.0348206841 -67.0604119056 3.56776039227 -23.0398206841 -67.0604119056 3.56776039227 -23.0448206841 -67.0604119056 3.56776039227 -23.0498206841 -67.0604119056 3.56776039227 -23.0548206841 -67.0604119056 3.56776039227 -23.0598206841 -67.0604119056 3.56776039227 -23.0648206841 -67.0604119056 3.56776039227 -23.0698206841 -67.0604119056 3.56776039227 -23.0748206841 -67.0604119056 3.56776039227 -23.0798206841 -67.0604119056 3.56776039227 -23.0848206841 -67.0604119056 3.56776039227 -23.0898206841 -67.0604119056 3.56776039227 -23.0948206841 -67.0604119056 3.56776039227 -23.0998206841 -67.0604119056 3.56776039227 -23.1048206841 -67.0604119056 3.56776039227 -23.1098206841 -67.0604119056 3.56776039227 -23.1148206841 -67.0604119056 3.56776039227 -23.1198206841 -67.0604119056 3.56776039227 -23.1248206841 -67.0604119056 3.56776039227 -23.1298206841 -67.0604119056 3.56776039227 -23.1348206841 -67.0604119056 3.56776039227 -23.1398206841 -67.0604119056 3.56776039227 -23.1448206841 -67.0604119056 3.56776039227 -23.1498206841 -67.0604119056 3.56776039227 -23.1548206841 -67.0604119056 3.56776039227 -23.1598206841 -67.0604119056 3.56776039227 -23.1648206841 -67.0604119056 3.56776039227 -23.1698206841 -67.0604119056 3.56776039227 -23.1748206841 -67.0604119056 3.56776039227 -23.1798206841 -67.0604119056 3.56776039227 -23.1848206841 -67.0604119056 3.56776039227 -23.1898206841 -67.0604119056 3.56776039227 -23.1948206841 -67.0604119056 3.56776039227 -23.1998206841 -67.0604119056 3.56776039227 -23.2048206841 -67.0604119056 3.56776039227 -23.2098206841 -67.0604119056 3.56776039227 -23.2148206841 -67.0604119056 3.56776039227 -23.2198206841 -67.0604119056 3.56776039227 -23.2248206841 -67.0604119056 3.56776039227 -23.2298206841 -67.0604119056 3.56776039227 -23.2348206841 -67.0604119056 3.56776039227 -23.2398206841 -67.0604119056 3.56776039227 -23.2448206841 -67.0604119056 3.56776039227 -23.2498206841 -67.0604119056 3.56776039227 -23.2548206841 -67.0604119056 3.56776039227 -23.2598206841 -67.0604119056 3.56776039227 -23.2648206841 -67.0604119056 3.56776039227 -23.2698206841 -67.0604119056 3.56776039227 -23.2748206841 -67.0604119056 3.56776039227 -23.2798206841 -67.0604119056 3.56776039227 -23.2848206841 -67.0604119056 3.56776039227 -23.2898206841 -67.0604119056 3.56776039227 -23.2948206841 -67.0604119056 3.56776039227 -23.2998206841 -67.0604119056 3.56776039227 -23.3048206841 -67.0604119056 3.56776039227 -23.3098206841 -67.0604119056 3.56776039227 -23.3148206841 -67.0604119056 3.56776039227 -23.3198206841 -67.0604119056 3.56776039227 -23.3248206841 -67.0604119056 3.56776039227 -23.3298206841 -67.0604119056 3.56776039227 -23.3348206841 -67.0604119056 3.56776039227 -23.3398206841 -67.0604119056 3.56776039227 -23.3448206841 -67.0604119056 3.56776039227 -23.3498206841 -67.0604119056 3.56776039227 -23.3548206841 -67.0604119056 3.56776039227 -23.3598206841 -67.0604119056 3.56776039227 -23.3648206841 -67.0604119056 3.56776039227 -23.3698206841 -67.0604119056 3.56776039227 -23.3748206841 -67.0604119056 3.56776039227 -23.3798206841 -67.0604119056 3.56776039227 -23.3848206841 -67.0604119056 3.56776039227 -23.3898206841 1415.9689283 3.56776039227 -23.3948206841 368.830896132 3.56776039227 -23.3998206841 -93.4873764626 3.56776039227 -23.4048206841 134.461782512 3.56776039227 -23.4098206841 1312.20516205 3.56776039227 -23.4148206841 1607.40922775 3.56776039227 -23.4198206841 1876.00964086 3.56776039227 -23.4248206841 1964.92919141 3.56776039227 -23.4298206841 1766.43953944 3.56776039227 -23.4348206841 1505.96862053 3.56776039227 -23.4398206841 1174.79049838 3.56776039227 -23.4448206841 933.867326166 3.56776039227 -23.4498206841 644.952012228 3.56776039227 -23.4548206841 447.357963158 3.56776039227 -23.4598206841 325.579817202 3.56776039227 -23.4648206841 289.043316715 3.56776039227 -23.4698206841 267.596501649 3.56776039227 -23.4748206841 264.851767212 3.56776039227 -23.4798206841 318.744022368 3.56776039227 -23.4848206841 358.680616391 3.56776039227 -23.4898206841 405.184706047 3.56776039227 -23.4948206841 460.160978828 3.56776039227 -23.4998206841 504.519356867 3.56776039227 -23.5048206841 541.788814902 3.56776039227 -23.5098206841 563.290320382 3.56776039227 -23.5148206841 581.955002556 10.9439054701 -23.5198206841 597.727127566 10.9439054701 -23.5248206841 606.616900924 10.9439054701 -23.5298206841 616.105753113 10.9439054701 -23.5348206841 615.972860205 10.9439054701 -23.5398206841 614.320478567 8.20021881341 -23.5448206841 616.363642734 6.55150280372 -23.5498206841 619.425848064 6.10308273218 -23.5548206841 616.536538537 15.4685111619 -23.5598206841 612.991868713 -20.3099768994 -23.5648206841 611.334149164 -20.3099768994 -23.5698206841 606.089200519 -20.3099768994 -23.5748206841 600.554828108 -20.3099768994 -23.5798206841 596.306029831 -20.3099768994 -23.5848206841 589.918357619 -20.3099768994 -23.5898206841 576.397042579 -20.3099768994 -23.5948206841 573.201754438 -20.3099768994 -23.5998206841 559.848213712 -20.3099768994 -23.6048206841 561.61114201 -20.3099768994 -23.6098206841 561.594842774 2.09478297346 -23.6148206841 561.231462134 2.01471969114 -23.6198206841 564.785046244 1.92045292882 -23.6248206841 572.294057878 1.82945733475 -23.6298206841 586.686369406 1.75372063114 -23.6348206841 599.795880992 1.6342780386 -23.6398206841 615.032181728 1.52583464517 -23.6448206841 635.107502996 1.42253590596 -23.6498206841 649.516040107 1.27438050178 -23.6548206841 672.287382564 1.27438050178 -23.6598206841 688.570946736 1.27438050178 -23.6648206841 705.712574625 2.39022099177 -23.6698206841 713.782326381 1.10955965792 -23.6748206841 731.569340733 0.75856725892 -23.6798206841 738.382741078 -0.575813762133 -23.6848206841 747.329564287 8.83918362009 -23.6898206841 755.937875421 8.83918362009 -23.6948206841 763.907788106 8.83918362009 -23.6998206841 774.394736164 8.83918362009 -23.7048206841 784.019969929 8.83918362009 -23.7098206841 794.931872967 8.83918362009 -23.7148206841 803.702097927 8.83918362009 -23.7198206841 813.177261614 8.83918362009 -23.7248206841 818.226687597 8.83918362009 -23.7298206841 835.991981492 8.83918362009 -23.7348206841 846.491701995 0.0578788262813 -23.7398206841 859.619638851 -0.142226284226 -23.7448206841 865.954966926 -0.416337313107 -23.7498206841 864.248642779 -0.416337313107 -23.7548206841 867.430275347 -0.416337313107 -23.7598206841 848.700758922 -0.416337313107 -23.7648206841 830.323932456 -0.416337313107 -23.7698206841 805.412586057 -0.416337313107 -23.7748206841 782.763735288 -0.416337313107 -23.7798206841 745.615391206 -0.416337313107 -23.7848206841 744.136944616 -0.416337313107 -23.7898206841 698.624471341 -0.416337313107 -23.7948206841 633.665258525 -0.416337313107 -23.7998206841 609.287064453 -0.416337313107 -23.8048206841 601.280938895 -0.416337313107 -23.8098206841 524.715582844 -0.416337313107 -23.8148206841 480.12467162 -0.416337313107 -23.8198206841 447.2132611 -0.416337313107 -23.8248206841 429.617406074 -0.416337313107 -23.8298206841 435.326681124 -0.416337313107 -23.8348206841 427.827503877 -0.416337313107 -23.8398206841 379.241999309 -0.416337313107 -23.8448206841 338.163506564 -0.416337313107 -23.8498206841 485.496050915 -0.416337313107 -23.8548206841 495.855399711 -0.416337313107 -23.8598206841 444.654922799 -0.416337313107 -23.8648206841 372.658721921 -0.416337313107 -23.8698206841 329.193421403 -0.416337313107 -23.8748206841 384.683397097 -0.416337313107 -23.8798206841 394.000856132 -0.416337313107 -23.8848206841 356.976700564 -0.416337313107 -23.8898206841 323.043179242 -0.416337313107 -23.8948206841 324.258466453 -0.416337313107 -23.8998206841 320.116743429 -0.416337313107 -23.9048206841 321.676169096 -0.416337313107 -23.9098206841 324.850038008 -0.416337313107 -23.9148206841 325.90274706 -0.416337313107 -23.9198206841 330.36794195 -0.416337313107 -23.9248206841 355.32997091 -0.416337313107 -23.9298206841 385.224758594 -0.416337313107 -23.9348206841 387.026826357 -0.416337313107 -23.9398206841 385.251815995 -0.416337313107 -23.9448206841 380.691065296 -0.416337313107 -23.9498206841 413.71185868 -0.416337313107 -23.9548206841 413.812980817 -0.416337313107 -23.9598206841 408.171871056 -0.416337313107 -23.9648206841 393.880641735 -0.416337313107 -23.9698206841 370.391517046 -0.416337313107 -23.9748206841 361.849180764 -0.416337313107 -23.9798206841 345.24862722 -0.416337313107 -23.9848206841 343.659231902 -0.416337313107 -23.9898206841 343.383742891 -0.416337313107 -23.9948206841 345.118560959 -0.416337313107 -23.9998206841 346.399425083 -0.416337313107 -24.0048206841 347.826413812 -0.416337313107 -24.0098206841 347.826413812 -0.416337313107 -24.0148206841 343.586933176 -0.416337313107 -24.0198206841 348.553542309 -0.416337313107 -24.0248206841 355.623215303 -0.416337313107 -24.0298206841 350.306385973 -0.416337313107 -24.0348206841 341.33868954 -0.416337313107 -24.0398206841 345.387066721 -0.416337313107 -24.0448206841 347.871055951 -0.416337313107 -24.0498206841 345.134297472 -0.416337313107 -24.0548206841 342.505735698 -0.416337313107 -24.0598206841 342.516519405 -0.416337313107 -24.0648206841 334.0415706 -0.416337313107 -24.0698206841 327.698643849 -0.416337313107 -24.0748206841 319.310746031 -0.416337313107 -24.0798206841 313.570647126 -0.416337313107 -24.0848206841 302.700502923 -0.416337313107 -24.0898206841 297.51393585 -0.416337313107 -24.0948206841 290.874536973 -0.416337313107 -24.0998206841 287.16873312 -0.416337313107 -24.1048206841 277.266397526 -0.416337313107 -24.1098206841 272.428025927 -0.416337313107 -24.1148206841 268.799378027 -0.416337313107 -24.1198206841 266.689687261 -0.416337313107 -24.1248206841 264.663183347 -0.416337313107 -24.1298206841 264.272310616 -0.416337313107 -24.1348206841 265.769161287 -0.416337313107 -24.1398206841 261.059368249 -0.416337313107 -24.1448206841 258.607910573 -0.416337313107 -24.1498206841 257.52490382 -0.416337313107 -24.1548206841 258.686203287 -0.416337313107 -24.1598206841 258.393477808 -0.416337313107 -24.1648206841 254.251310813 -0.416337313107 -24.1698206841 248.401417287 -0.416337313107 -24.1748206841 242.056180159 -0.416337313107 -24.1798206841 234.694007658 -0.416337313107 -24.1848206841 225.004740653 -0.416337313107 -24.1898206841 216.205195996 -0.416337313107 -24.1948206841 204.969046373 -0.416337313107 -24.1998206841 196.821573059 -0.416337313107 -24.2048206841 189.188708126 -0.416337313107 -24.2098206841 180.21710636 -0.416337313107 -24.2148206841 171.168589549 -0.416337313107 -24.2198206841 151.044082236 -0.416337313107 -24.2248206841 138.949561643 -0.416337313107 -24.2298206841 131.762457131 -0.416337313107 -24.2348206841 128.302120322 -0.416337313107 -24.2398206841 121.397432718 -0.416337313107 -24.2448206841 120.903254041 -0.416337313107 -24.2498206841 111.845869326 -0.416337313107 -24.2548206841 104.227712312 -0.416337313107 -24.2598206841 93.861069934 -0.416337313107 -24.2648206841 78.8918182779 -0.416337313107 -24.2698206841 72.6427501752 -0.416337313107 -24.2748206841 72.1071740356 -0.416337313107 -24.2798206841 66.7701431013 -0.416337313107 -24.2848206841 54.9472747837 -0.416337313107 -24.2898206841 47.8136458091 -0.416337313107 -24.2948206841 44.6509252866 -0.416337313107 -24.2998206841 21.5336628727 -0.416337313107 -24.3048206841 10.585233998 -0.416337313107 -24.3098206841 -0.149082134896 -0.416337313107 -24.3148206841 3.66520568298 -0.416337313107 -24.3198206841 7.22791663892 -0.416337313107 -24.3248206841 6.05087487647 -0.416337313107 -24.3298206841 1.48803481113 -0.416337313107 -24.3348206841 2.56550041295 -0.416337313107 -24.3398206841 -10.5615508441 -0.416337313107 -24.3448206841 -25.3798448451 -0.416337313107 -24.3498206841 -41.057804929 -0.416337313107 -24.3548206841 -55.313825909 -0.416337313107 -24.3598206841 -55.313825909 -0.416337313107 -24.3648206841 -55.313825909 -0.416337313107 -24.3698206841 -55.313825909 -0.416337313107 -24.3748206841 -55.313825909 -0.416337313107 -24.3798206841 -55.313825909 -0.416337313107 -24.3848206841 -55.313825909 -0.416337313107 -24.3898206841 -55.313825909 -0.416337313107 -24.3948206841 -55.313825909 -0.416337313107 -24.3998206841 -55.313825909 -0.416337313107 -24.4048206841 -55.313825909 -0.416337313107 -24.4098206841 -55.313825909 -0.416337313107 -24.4148206841 -55.313825909 -0.416337313107 -24.4198206841 -55.313825909 -0.416337313107 -24.4248206841 -55.313825909 -0.416337313107 -24.4298206841 -55.313825909 -0.416337313107 -24.4348206841 -55.313825909 -0.416337313107 -24.4398206841 -55.313825909 -0.416337313107 -24.4448206841 -55.313825909 -0.416337313107 -24.4498206841 -55.313825909 -0.416337313107 -24.4548206841 -55.313825909 -0.416337313107 -24.4598206841 -55.313825909 -0.416337313107 -24.4648206841 -55.313825909 -0.416337313107 -24.4698206841 -55.313825909 -0.416337313107 -24.4748206841 -55.313825909 -0.416337313107 -24.4798206841 -55.313825909 -0.416337313107 -24.4848206841 -55.313825909 -0.416337313107 -24.4898206841 -55.313825909 -0.416337313107 -24.4948206841 -55.313825909 -0.416337313107 -24.4998206841 -55.313825909 -0.416337313107 -24.5048206841 -55.313825909 -0.416337313107 -24.5098206841 -55.313825909 -0.416337313107 -24.5148206841 -55.313825909 -0.416337313107 -24.5198206841 -55.313825909 -0.416337313107 -24.5248206841 -55.313825909 -0.416337313107 -24.5298206841 -55.313825909 -0.416337313107 -24.5348206841 -55.313825909 -0.416337313107 -24.5398206841 -55.313825909 -0.416337313107 -24.5448206841 -55.313825909 -0.416337313107 -24.5498206841 -55.313825909 -0.416337313107 -24.5548206841 -55.313825909 -0.416337313107 -24.5598206841 -55.313825909 -0.416337313107 -24.5648206841 -55.313825909 -0.416337313107 -24.5698206841 -55.313825909 -0.416337313107 -24.5748206841 -55.313825909 -0.416337313107 -24.5798206841 -55.313825909 -0.416337313107 -24.5848206841 -55.313825909 -0.416337313107 -24.5898206841 -55.313825909 -0.416337313107 -24.5948206841 -55.313825909 -0.416337313107 -24.5998206841 -55.313825909 -0.416337313107 -24.6048206841 -55.313825909 -0.416337313107 -24.6098206841 -55.313825909 -0.416337313107 -24.6148206841 -55.313825909 -0.416337313107 -24.6198206841 -55.313825909 -0.416337313107 -24.6248206841 -55.313825909 -0.416337313107 -24.6298206841 -55.313825909 -0.416337313107 -24.6348206841 -55.313825909 -0.416337313107 -24.6398206841 -55.313825909 -0.416337313107 -24.6448206841 -55.313825909 -0.416337313107 -24.6498206841 -55.313825909 -0.416337313107 -24.6548206841 -55.313825909 -0.416337313107 -24.6598206841 -55.313825909 -0.416337313107 -24.6648206841 -55.313825909 -0.416337313107 -24.6698206841 -55.313825909 -0.416337313107 -24.6748206841 -55.313825909 -0.416337313107 -24.6798206841 -55.313825909 -0.416337313107 -24.6848206841 -55.313825909 -0.416337313107 -24.6898206841 -55.313825909 -0.416337313107 -24.6948206841 -55.313825909 -0.416337313107 -24.6998206841 -55.313825909 -0.416337313107 -24.7048206841 -55.313825909 -0.416337313107 -24.7098206841 -55.313825909 -0.416337313107 -24.7148206841 -55.313825909 -0.416337313107 -24.7198206841 -55.313825909 -0.416337313107 -24.7248206841 -55.313825909 -0.416337313107 -24.7298206841 -55.313825909 -0.416337313107 -24.7348206841 -55.313825909 -0.416337313107 -24.7398206841 -55.313825909 -0.416337313107 -24.7448206841 -55.313825909 -0.416337313107 -24.7498206841 -55.313825909 -0.416337313107 -24.7548206841 -55.313825909 -0.416337313107 -24.7598206841 -55.313825909 -0.416337313107 -24.7648206841 -55.313825909 -0.416337313107 -24.7698206841 -55.313825909 -0.416337313107 -24.7748206841 -55.313825909 -0.416337313107 -24.7798206841 -55.313825909 -0.416337313107 -24.7848206841 -55.313825909 -0.416337313107 -24.7898206841 -55.313825909 -0.416337313107 -24.7948206841 -55.313825909 -0.416337313107 -24.7998206841 -55.313825909 -0.416337313107 -24.8048206841 -55.313825909 -0.416337313107 -24.8098206841 -55.313825909 -0.416337313107 -24.8148206841 -55.313825909 -0.416337313107 -24.8198206841 -55.313825909 -0.416337313107 -24.8248206841 -55.313825909 -0.416337313107 -24.8298206841 -55.313825909 -0.416337313107 -24.8348206841 -55.313825909 -0.416337313107 -24.8398206841 -55.313825909 -0.416337313107 -24.8448206841 -55.313825909 -0.416337313107 -24.8498206841 -55.313825909 -0.416337313107 -24.8548206841 -55.313825909 -0.416337313107 -24.8598206841 -55.313825909 -0.416337313107 -24.8648206841 -55.313825909 -0.416337313107 -24.8698206841 -55.313825909 -0.416337313107 -24.8748206841 -55.313825909 -0.416337313107 -24.8798206841 -55.313825909 -0.416337313107 -24.8848206841 -55.313825909 -0.416337313107 -24.8898206841 -55.313825909 -0.416337313107 -24.8948206841 -55.313825909 -0.416337313107 -24.8998206841 -55.313825909 -0.416337313107 -24.9048206841 -55.313825909 -0.416337313107 -24.9098206841 -55.313825909 -0.416337313107 -24.9148206841 -55.313825909 -0.416337313107 -24.9198206841 -55.313825909 -0.416337313107 -24.9248206841 -55.313825909 -0.416337313107 -24.9298206841 -55.313825909 -0.416337313107 -24.9348206841 -55.313825909 -0.416337313107 -24.9398206841 -55.313825909 -0.416337313107 -24.9448206841 -55.313825909 -0.416337313107 -24.9498206841 -55.313825909 -0.416337313107 -24.9548206841 -55.313825909 -0.416337313107 -24.9598206841 -55.313825909 -0.416337313107 -24.9648206841 -55.313825909 -0.416337313107 -24.9698206841 -55.313825909 -0.416337313107 -24.9748206841 -55.313825909 -0.416337313107 -24.9798206841 -55.313825909 -0.416337313107 -24.9848206841 -55.313825909 -0.416337313107 -24.9898206841 -55.313825909 -0.416337313107 -24.9948206841 -55.313825909 -0.416337313107 -24.9998206841 -55.313825909 -0.416337313107 -25.0048206841 -55.313825909 -0.416337313107 -25.0098206841 -55.313825909 -0.416337313107 -25.0148206841 -55.313825909 -0.416337313107 -25.0198206841 -55.313825909 -0.416337313107 -25.0248206841 -55.313825909 -0.416337313107 -25.0298206841 -55.313825909 -0.416337313107 -25.0348206841 -55.313825909 -0.416337313107 -25.0398206841 -55.313825909 -0.416337313107 -25.0448206841 -55.313825909 -0.416337313107 -25.0498206841 -55.313825909 -0.416337313107 -25.0548206841 -55.313825909 -0.416337313107 -25.0598206841 -55.313825909 -0.416337313107 -25.0648206841 -55.313825909 -0.416337313107 -25.0698206841 -55.313825909 -0.416337313107 -25.0748206841 -55.313825909 -0.416337313107 -25.0798206841 -55.313825909 -0.416337313107 -25.0848206841 -55.313825909 -0.416337313107 -25.0898206841 -55.313825909 -0.416337313107 -25.0948206841 -55.313825909 -0.416337313107 -25.0998206841 -55.313825909 -0.416337313107 -25.1048206841 -55.313825909 -0.416337313107 -25.1098206841 -55.313825909 -0.416337313107 -25.1148206841 -55.313825909 -0.416337313107 -25.1198206841 -55.313825909 -0.416337313107 -25.1248206841 -55.313825909 -0.416337313107 -25.1298206841 -55.313825909 -0.416337313107 -25.1348206841 -55.313825909 -0.416337313107 -25.1398206841 -55.313825909 -0.416337313107 -25.1448206841 -55.313825909 -0.416337313107 -25.1498206841 -55.313825909 -0.416337313107 -25.1548206841 -55.313825909 -0.416337313107 -25.1598206841 -55.313825909 -0.416337313107 -25.1648206841 -55.313825909 -0.416337313107 -25.1698206841 -55.313825909 -0.416337313107 -25.1748206841 -55.313825909 -0.416337313107 -25.1798206841 -55.313825909 -0.416337313107 -25.1848206841 -55.313825909 -0.416337313107 -25.1898206841 -55.313825909 -0.416337313107 -25.1948206841 -55.313825909 -0.416337313107 -25.1998206841 -55.313825909 -0.416337313107 -25.2048206841 -55.313825909 -0.416337313107 -25.2098206841 -55.313825909 -0.416337313107 -25.2148206841 -55.313825909 -0.416337313107 -25.2198206841 -55.313825909 -0.416337313107 -25.2248206841 -55.313825909 -0.416337313107 -25.2298206841 -55.313825909 -0.416337313107 -25.2348206841 -55.313825909 -0.416337313107 -25.2398206841 -55.313825909 -0.416337313107 -25.2448206841 -55.313825909 -0.416337313107 -25.2498206841 -55.313825909 -0.416337313107 -25.2548206841 -55.313825909 -0.416337313107 -25.2598206841 -55.313825909 -0.416337313107 -25.2648206841 -55.313825909 -0.416337313107 -25.2698206841 -55.313825909 -0.416337313107 -25.2748206841 -55.313825909 -0.416337313107 -25.2798206841 -55.313825909 -0.416337313107 -25.2848206841 -55.313825909 -0.416337313107 -25.2898206841 -55.313825909 -0.416337313107 -25.2948206841 497.970001145 -0.416337313107 -25.2998206841 281.959583325 -0.416337313107 -25.3048206841 216.603435744 -0.416337313107 -25.3098206841 325.100318184 -0.416337313107 -25.3148206841 649.262740251 -0.416337313107 -25.3198206841 1634.56092538 -0.416337313107 -25.3248206841 1734.55459182 -0.416337313107 -25.3298206841 1653.51418544 -0.416337313107 -25.3348206841 1592.42501396 -0.416337313107 -25.3398206841 1431.89089677 -0.416337313107 -25.3448206841 1276.29824702 -0.416337313107 -25.3498206841 1109.95336979 -0.416337313107 -25.3548206841 942.185929612 -0.416337313107 -25.3598206841 873.392135857 -0.416337313107 -25.3648206841 748.07410799 -0.416337313107 -25.3698206841 651.055955496 -0.416337313107 -25.3748206841 556.082405782 -0.416337313107 -25.3798206841 470.357171762 -0.416337313107 -25.3848206841 417.198614242 -0.416337313107 -25.3898206841 382.573336209 -0.416337313107 -25.3948206841 370.126264011 -0.416337313107 -25.3998206841 370.367746357 -0.416337313107 -25.4048206841 401.427342796 -0.416337313107 -25.4098206841 443.863946367 -0.416337313107 -25.4148206841 488.222415852 -0.416337313107 -25.4198206841 532.544062299 -0.416337313107 -25.4248206841 570.59824649 -0.416337313107 -25.4298206841 605.276434906 -0.416337313107 -25.4348206841 634.226974433 -0.416337313107 -25.4398206841 651.926208589 -0.416337313107 -25.4448206841 659.302045412 -0.416337313107 -25.4498206841 661.58307523 -0.416337313107 -25.4548206841 656.944368705 -0.416337313107 -25.4598206841 648.804338992 -0.416337313107 -25.4648206841 634.433492625 -0.416337313107 -25.4698206841 616.803333535 -0.416337313107 -25.4748206841 599.340562774 -0.416337313107 -25.4798206841 582.112991929 -0.416337313107 -25.4848206841 564.058652893 -0.416337313107 -25.4898206841 551.691754127 -0.416337313107 -25.4948206841 543.214365772 -0.416337313107 -25.4998206841 537.771234046 -0.416337313107 -25.5048206841 534.996614228 -0.416337313107 -25.5098206841 534.519064985 -0.416337313107 -25.5148206841 537.069625519 -0.416337313107 -25.5198206841 542.262233164 -0.416337313107 -25.5248206841 549.124460616 -0.416337313107 -25.5298206841 558.096881473 -0.416337313107 -25.5348206841 568.942821371 -0.416337313107 -25.5398206841 584.246508188 -0.416337313107 -25.5448206841 598.268190816 -0.416337313107 -25.5498206841 611.93928826 -0.416337313107 -25.5548206841 627.10176199 -0.416337313107 -25.5598206841 640.907899247 -0.416337313107 -25.5648206841 653.098964764 -0.416337313107 -25.5698206841 665.845491414 -0.416337313107 -25.5748206841 676.947927287 -0.416337313107 -25.5798206841 689.370398806 -0.416337313107 -25.5848206841 702.049669358 -0.416337313107 -25.5898206841 721.523422731 -0.416337313107 -25.5948206841 746.980132761 -0.416337313107 -25.5998206841 769.412766727 -0.416337313107 -25.6048206841 775.659524414 -0.416337313107 -25.6098206841 797.735118321 -0.416337313107 -25.6148206841 813.129552366 -0.416337313107 -25.6198206841 829.460480838 -0.416337313107 -25.6248206841 863.468856439 -0.416337313107 -25.6298206841 881.699809794 -0.416337313107 -25.6348206841 869.868487065 -0.416337313107 -25.6398206841 869.364365507 -0.416337313107 -25.6448206841 911.35447558 -0.416337313107 -25.6498206841 890.653591478 -0.416337313107 -25.6548206841 875.227440804 -0.416337313107 -25.6598206841 857.500189499 -0.416337313107 -25.6648206841 873.747692773 -0.416337313107 -25.6698206841 856.680455105 -0.416337313107 -25.6748206841 832.599405791 -0.416337313107 -25.6798206841 821.602266374 -0.416337313107 -25.6848206841 776.594391039 -0.416337313107 -25.6898206841 743.802727869 -0.416337313107 -25.6948206841 701.246594427 -0.416337313107 -25.6998206841 684.452991645 -0.416337313107 -25.7048206841 652.166789183 -0.416337313107 -25.7098206841 626.2937587 -0.416337313107 -25.7148206841 595.730464443 -0.416337313107 -25.7198206841 574.836222067 -0.416337313107 -25.7248206841 543.30850262 -0.416337313107 -25.7298206841 526.381980943 -0.416337313107 -25.7348206841 508.403513522 -0.416337313107 -25.7398206841 490.009957198 -0.416337313107 -25.7448206841 474.13454183 -0.416337313107 -25.7498206841 458.471629365 -0.416337313107 -25.7548206841 439.316243111 -0.416337313107 -25.7598206841 424.537735824 -0.416337313107 -25.7648206841 406.923821042 -0.416337313107 -25.7698206841 400.63133925 -0.416337313107 -25.7748206841 379.695487009 -0.416337313107 -25.7798206841 341.802853475 -0.416337313107 -25.7848206841 334.866375959 -0.416337313107 -25.7898206841 326.281119808 -0.416337313107 -25.7948206841 314.349799932 -0.416337313107 -25.7998206841 307.221697734 -0.416337313107 -25.8048206841 295.28649434 -0.416337313107 -25.8098206841 281.933091741 -0.416337313107 -25.8148206841 270.795512161 -0.416337313107 -25.8198206841 256.326971367 -0.416337313107 -25.8248206841 250.540540114 -0.416337313107 -25.8298206841 240.730476056 -0.416337313107 -25.8348206841 228.5332707 -0.416337313107 -25.8398206841 214.186977308 -0.416337313107 -25.8448206841 202.389790373 -0.416337313107 -25.8498206841 197.201844561 -0.416337313107 -25.8548206841 209.180163657 -0.416337313107 -25.8598206841 217.958855297 -0.416337313107 -25.8648206841 240.939203836 -0.416337313107 -25.8698206841 272.62903724 -0.416337313107 -25.8748206841 291.603465347 -0.416337313107 -25.8798206841 304.458890115 -0.416337313107 -25.8848206841 318.13365226 -0.416337313107 -25.8898206841 323.355620863 -0.416337313107 -25.8948206841 329.73871185 -0.416337313107 -25.8998206841 345.162199366 -0.416337313107 -25.9048206841 356.924126597 -0.416337313107 -25.9098206841 364.501097433 -0.416337313107 -25.9148206841 369.1505993 -0.416337313107 -25.9198206841 377.364026233 -0.416337313107 -25.9248206841 372.93412108 -0.416337313107 -25.9298206841 373.156488487 -0.416337313107 -25.9348206841 366.451932368 -0.416337313107 -25.9398206841 351.654296916 -0.416337313107 -25.9448206841 340.996610061 -0.416337313107 -25.9498206841 329.012578716 -0.416337313107 -25.9548206841 319.795547625 -0.416337313107 -25.9598206841 309.915241454 -0.416337313107 -25.9648206841 300.139066787 -0.416337313107 -25.9698206841 289.993117282 -0.416337313107 -25.9748206841 283.70107875 -0.416337313107 -25.9798206841 279.94691908 -0.416337313107 -25.9848206841 278.669544803 -0.416337313107 -25.9898206841 281.058721495 -0.416337313107 -25.9948206841 278.094326337 -0.416337313107 -25.9998206841 276.986936598 -0.416337313107 -26.0048206841 276.429167989 -0.416337313107 -26.0098206841 279.671116756 -0.416337313107 -26.0148206841 280.316716864 -0.416337313107 -26.0198206841 283.678556152 -0.416337313107 -26.0248206841 278.317569079 -0.416337313107 -26.0298206841 279.124957131 -0.416337313107 -26.0348206841 274.679818369 -0.416337313107 -26.0398206841 272.681905814 -0.416337313107 -26.0448206841 269.499717948 -0.416337313107 -26.0498206841 266.554113959 -0.416337313107 -26.0548206841 260.393203502 -0.416337313107 -26.0598206841 253.881572126 -0.416337313107 -26.0648206841 249.920948507 -0.416337313107 -26.0698206841 243.110452883 -0.416337313107 -26.0748206841 236.382565629 -0.416337313107 -26.0798206841 232.552869126 -0.416337313107 -26.0848206841 233.088401753 -0.416337313107 -26.0898206841 227.584325075 -0.416337313107 -26.0948206841 216.825010284 -0.416337313107 -26.0998206841 212.797311896 -0.416337313107 -26.1048206841 207.343660118 -0.416337313107 -26.1098206841 203.870907926 -0.416337313107 -26.1148206841 200.346272098 -0.416337313107 -26.1198206841 195.905976479 -0.416337313107 -26.1248206841 192.916255857 -0.416337313107 -26.1298206841 190.286686299 -0.416337313107 -26.1348206841 183.703407867 -0.416337313107 -26.1398206841 174.385823194 -0.416337313107 -26.1448206841 171.73170699 -0.416337313107 -26.1498206841 166.579574854 -0.416337313107 -26.1548206841 149.412342821 -0.416337313107 -26.1598206841 134.20130343 -0.416337313107 -26.1648206841 119.332048377 -0.416337313107 -26.1698206841 106.290251529 -0.416337313107 -26.1748206841 99.5536247461 -0.416337313107 -26.1798206841 93.1530246763 -0.416337313107 -26.1848206841 80.7764873233 -0.416337313107 -26.1898206841 77.4576277389 -0.416337313107 -26.1948206841 60.3957380903 -0.416337313107 -26.1998206841 47.0115569772 -0.416337313107 -26.2048206841 35.1951887597 -0.416337313107 -26.2098206841 25.3691716848 -0.416337313107 -26.2148206841 17.307278667 -0.416337313107 -26.2198206841 3.07434084677 -0.416337313107 -26.2248206841 3.97184141824 -0.416337313107 -26.2298206841 6.47183941811 -0.416337313107 -26.2348206841 -0.923312091492 -0.416337313107 -26.2398206841 -5.90030711691 -0.416337313107 -26.2448206841 -22.4012283448 -0.416337313107 -26.2498206841 -35.0206892202 -0.416337313107 -26.2548206841 -48.1396442674 -0.416337313107 -26.2598206841 -60.9448014734 -0.416337313107 -26.2648206841 -65.0631965136 -0.416337313107 -26.2698206841 -68.4097973741 -0.416337313107 -26.2748206841 -68.4097973741 -0.416337313107 -26.2798206841 -68.4097973741 -0.416337313107 -26.2848206841 -68.4097973741 -0.416337313107 -26.2898206841 -68.4097973741 -0.416337313107 -26.2948206841 -68.4097973741 -0.416337313107 -26.2998206841 -68.4097973741 -0.416337313107 -26.3048206841 -68.4097973741 -0.416337313107 -26.3098206841 -68.4097973741 -0.416337313107 -26.3148206841 -68.4097973741 -0.416337313107 -26.3198206841 -68.4097973741 -0.416337313107 -26.3248206841 -68.4097973741 -0.416337313107 -26.3298206841 -68.4097973741 -0.416337313107 -26.3348206841 -68.4097973741 -0.416337313107 -26.3398206841 -68.4097973741 -0.416337313107 -26.3448206841 -68.4097973741 -0.416337313107 -26.3498206841 -68.4097973741 -0.416337313107 -26.3548206841 -68.4097973741 -0.416337313107 -26.3598206841 -68.4097973741 -0.416337313107 -26.3648206841 -68.4097973741 -0.416337313107 -26.3698206841 -68.4097973741 -0.416337313107 -26.3748206841 -68.4097973741 -0.416337313107 -26.3798206841 -68.4097973741 -0.416337313107 -26.3848206841 -68.4097973741 -0.416337313107 -26.3898206841 -68.4097973741 -0.416337313107 -26.3948206841 -68.4097973741 -0.416337313107 -26.3998206841 -68.4097973741 -0.416337313107 -26.4048206841 -68.4097973741 -0.416337313107 -26.4098206841 -68.4097973741 -0.416337313107 -26.4148206841 -68.4097973741 -0.416337313107 -26.4198206841 -68.4097973741 -0.416337313107 -26.4248206841 -68.4097973741 -0.416337313107 -26.4298206841 -68.4097973741 -0.416337313107 -26.4348206841 -68.4097973741 -0.416337313107 -26.4398206841 -68.4097973741 -0.416337313107 -26.4448206841 -68.4097973741 -0.416337313107 -26.4498206841 -68.4097973741 -0.416337313107 -26.4548206841 -68.4097973741 -0.416337313107 -26.4598206841 -68.4097973741 -0.416337313107 -26.4648206841 -68.4097973741 -0.416337313107 -26.4698206841 -68.4097973741 -0.416337313107 -26.4748206841 -68.4097973741 -0.416337313107 -26.4798206841 -68.4097973741 -0.416337313107 -26.4848206841 -68.4097973741 -0.416337313107 -26.4898206841 -68.4097973741 -0.416337313107 -26.4948206841 -68.4097973741 -0.416337313107 -26.4998206841 -68.4097973741 -0.416337313107 -26.5048206841 -68.4097973741 -0.416337313107 -26.5098206841 -68.4097973741 -0.416337313107 -26.5148206841 -68.4097973741 -0.416337313107 -26.5198206841 -68.4097973741 -0.416337313107 -26.5248206841 -68.4097973741 -0.416337313107 -26.5298206841 -68.4097973741 -0.416337313107 -26.5348206841 -68.4097973741 -0.416337313107 -26.5398206841 -68.4097973741 -0.416337313107 -26.5448206841 -68.4097973741 -0.416337313107 -26.5498206841 -68.4097973741 -0.416337313107 -26.5548206841 -68.4097973741 -0.416337313107 -26.5598206841 -68.4097973741 -0.416337313107 -26.5648206841 -68.4097973741 -0.416337313107 -26.5698206841 -68.4097973741 -0.416337313107 -26.5748206841 -68.4097973741 -0.416337313107 -26.5798206841 -68.4097973741 -0.416337313107 -26.5848206841 -68.4097973741 -0.416337313107 -26.5898206841 -68.4097973741 -0.416337313107 -26.5948206841 -68.4097973741 -0.416337313107 -26.5998206841 -68.4097973741 -0.416337313107 -26.6048206841 -68.4097973741 -0.416337313107 -26.6098206841 -68.4097973741 -0.416337313107 -26.6148206841 -68.4097973741 -0.416337313107 -26.6198206841 -68.4097973741 -0.416337313107 -26.6248206841 -68.4097973741 -0.416337313107 -26.6298206841 -68.4097973741 -0.416337313107 -26.6348206841 -68.4097973741 -0.416337313107 -26.6398206841 -68.4097973741 -0.416337313107 -26.6448206841 -68.4097973741 -0.416337313107 -26.6498206841 -68.4097973741 -0.416337313107 -26.6548206841 -68.4097973741 -0.416337313107 -26.6598206841 -68.4097973741 -0.416337313107 -26.6648206841 -68.4097973741 -0.416337313107 -26.6698206841 -68.4097973741 -0.416337313107 -26.6748206841 -68.4097973741 -0.416337313107 -26.6798206841 -68.4097973741 -0.416337313107 -26.6848206841 -68.4097973741 -0.416337313107 -26.6898206841 -68.4097973741 -0.416337313107 -26.6948206841 -68.4097973741 -0.416337313107 -26.6998206841 -68.4097973741 -0.416337313107 -26.7048206841 -68.4097973741 -0.416337313107 -26.7098206841 -68.4097973741 -0.416337313107 -26.7148206841 -68.4097973741 -0.416337313107 -26.7198206841 -68.4097973741 -0.416337313107 -26.7248206841 -68.4097973741 -0.416337313107 -26.7298206841 -68.4097973741 -0.416337313107 -26.7348206841 -68.4097973741 -0.416337313107 -26.7398206841 -68.4097973741 -0.416337313107 -26.7448206841 -68.4097973741 -0.416337313107 -26.7498206841 -68.4097973741 -0.416337313107 -26.7548206841 -68.4097973741 -0.416337313107 -26.7598206841 -68.4097973741 -0.416337313107 -26.7648206841 -68.4097973741 -0.416337313107 -26.7698206841 -68.4097973741 -0.416337313107 -26.7748206841 -68.4097973741 -0.416337313107 -26.7798206841 -68.4097973741 -0.416337313107 -26.7848206841 -68.4097973741 -0.416337313107 -26.7898206841 -68.4097973741 -0.416337313107 -26.7948206841 -68.4097973741 -0.416337313107 -26.7998206841 -68.4097973741 -0.416337313107 -26.8048206841 -68.4097973741 -0.416337313107 -26.8098206841 -68.4097973741 -0.416337313107 -26.8148206841 -68.4097973741 -0.416337313107 -26.8198206841 -68.4097973741 -0.416337313107 -26.8248206841 -68.4097973741 -0.416337313107 -26.8298206841 -68.4097973741 -0.416337313107 -26.8348206841 -68.4097973741 -0.416337313107 -26.8398206841 -68.4097973741 -0.416337313107 -26.8448206841 -68.4097973741 -0.416337313107 -26.8498206841 -68.4097973741 -0.416337313107 -26.8548206841 -68.4097973741 -0.416337313107 -26.8598206841 -68.4097973741 -0.416337313107 -26.8648206841 -68.4097973741 -0.416337313107 -26.8698206841 -68.4097973741 -0.416337313107 -26.8748206841 -68.4097973741 -0.416337313107 -26.8798206841 -68.4097973741 -0.416337313107 -26.8848206841 -68.4097973741 -0.416337313107 -26.8898206841 -68.4097973741 -0.416337313107 -26.8948206841 -68.4097973741 -0.416337313107 -26.8998206841 -68.4097973741 -0.416337313107 -26.9048206841 -68.4097973741 -0.416337313107 -26.9098206841 -68.4097973741 -0.416337313107 -26.9148206841 -68.4097973741 -0.416337313107 -26.9198206841 -68.4097973741 -0.416337313107 -26.9248206841 -68.4097973741 -0.416337313107 -26.9298206841 -68.4097973741 -0.416337313107 -26.9348206841 -68.4097973741 -0.416337313107 -26.9398206841 -68.4097973741 -0.416337313107 -26.9448206841 -68.4097973741 -0.416337313107 -26.9498206841 -68.4097973741 -0.416337313107 -26.9548206841 -68.4097973741 -0.416337313107 -26.9598206841 -68.4097973741 -0.416337313107 -26.9648206841 -68.4097973741 -0.416337313107 -26.9698206841 -68.4097973741 -0.416337313107 -26.9748206841 -68.4097973741 -0.416337313107 -26.9798206841 -68.4097973741 -0.416337313107 -26.9848206841 -68.4097973741 -0.416337313107 -26.9898206841 -68.4097973741 -0.416337313107 -26.9948206841 -68.4097973741 -0.416337313107 -26.9998206841 -68.4097973741 -0.416337313107 -27.0048206841 -68.4097973741 -0.416337313107 -27.0098206841 -68.4097973741 -0.416337313107 -27.0148206841 -68.4097973741 -0.416337313107 -27.0198206841 -68.4097973741 -0.416337313107 -27.0248206841 -68.4097973741 -0.416337313107 -27.0298206841 -68.4097973741 -0.416337313107 -27.0348206841 -68.4097973741 -0.416337313107 -27.0398206841 -68.4097973741 -0.416337313107 -27.0448206841 -68.4097973741 -0.416337313107 -27.0498206841 -68.4097973741 -0.416337313107 -27.0548206841 -68.4097973741 -0.416337313107 -27.0598206841 -68.4097973741 -0.416337313107 -27.0648206841 -68.4097973741 -0.416337313107 -27.0698206841 -68.4097973741 -0.416337313107 -27.0748206841 -68.4097973741 -0.416337313107 -27.0798206841 -68.4097973741 -0.416337313107 -27.0848206841 -68.4097973741 -0.416337313107 -27.0898206841 -68.4097973741 -0.416337313107 -27.0948206841 -68.4097973741 -0.416337313107 -27.0998206841 -68.4097973741 -0.416337313107 -27.1048206841 -68.4097973741 -0.416337313107 -27.1098206841 -68.4097973741 -0.416337313107 -27.1148206841 -68.4097973741 -0.416337313107 -27.1198206841 -68.4097973741 -0.416337313107 -27.1248206841 -68.4097973741 -0.416337313107 -27.1298206841 -68.4097973741 -0.416337313107 -27.1348206841 -68.4097973741 -0.416337313107 -27.1398206841 -68.4097973741 -0.416337313107 -27.1448206841 -68.4097973741 -0.416337313107 -27.1498206841 -68.4097973741 -0.416337313107 -27.1548206841 -68.4097973741 -0.416337313107 -27.1598206841 -68.4097973741 -0.416337313107 -27.1648206841 -68.4097973741 -0.416337313107 -27.1698206841 -68.4097973741 -0.416337313107 -27.1748206841 -68.4097973741 -0.416337313107 -27.1798206841 -68.4097973741 -0.416337313107 -27.1848206841 -68.4097973741 -0.416337313107 -27.1898206841 -68.4097973741 -0.416337313107 -27.1948206841 -68.4097973741 -0.416337313107 -27.1998206841 -68.4097973741 -0.416337313107 -27.2048206841 1439.49258978 -0.416337313107 -27.2098206841 845.503493733 -0.416337313107 -27.2148206841 909.696642589 -0.416337313107 -27.2198206841 1348.45658941 -0.416337313107 -27.2248206841 1678.28729527 -0.416337313107 -27.2298206841 1606.20058639 -0.416337313107 -27.2348206841 1431.04281736 -0.416337313107 -27.2398206841 1058.24303112 -0.416337313107 -27.2448206841 964.438200755 -0.416337313107 -27.2498206841 777.180514071 -0.416337313107 -27.2548206841 612.312925855 -0.416337313107 -27.2598206841 500.538104293 -0.416337313107 -27.2648206841 422.813304741 -0.416337313107 -27.2698206841 372.986227985 -0.416337313107 -27.2748206841 342.791895553 -0.416337313107 -27.2798206841 350.471970247 -0.416337313107 -27.2848206841 380.282597876 -0.416337313107 -27.2898206841 407.905284178 -0.416337313107 -27.2948206841 445.933403913 -0.416337313107 -27.2998206841 485.791562484 -0.416337313107 -27.3048206841 533.587357374 -0.416337313107 -27.3098206841 565.383958468 -0.416337313107 -27.3148206841 586.584730866 -0.416337313107 -27.3198206841 595.396984915 -0.416337313107 -27.3248206841 594.97773777 -0.416337313107 -27.3298206841 585.085126657 -0.416337313107 -27.3348206841 569.799937596 -0.416337313107 -27.3398206841 555.831229277 -0.416337313107 -27.3448206841 539.133387671 -0.416337313107 -27.3498206841 529.240539937 -0.416337313107 -27.3548206841 521.176850122 -0.416337313107 -27.3598206841 516.212936186 -0.416337313107 -27.3648206841 519.216749043 -0.416337313107 -27.3698206841 521.890380409 -0.416337313107 -27.3748206841 522.978100598 -0.416337313107 -27.3798206841 528.900818537 6.91600165289 -27.3848206841 533.143220308 7.04867649337 -27.3898206841 537.200615685 7.99166695268 -27.3948206841 543.798869365 8.17160013778 -27.3998206841 551.237354278 8.17160013778 -27.4048206841 557.030620636 8.17160013778 -27.4098206841 558.796834854 8.17160013778 -27.4148206841 559.138656286 8.17160013778 -27.4198206841 558.565647608 8.17160013778 -27.4248206841 556.039128546 8.17160013778 -27.4298206841 555.299870464 8.17160013778 -27.4348206841 559.11661096 8.17160013778 -27.4398206841 564.47776964 8.17160013778 -27.4448206841 573.002050927 8.17160013778 -27.4498206841 579.295184833 8.17160013778 -27.4548206841 590.583039751 8.17160013778 -27.4598206841 603.460487594 8.17160013778 -27.4648206841 611.429500754 8.17160013778 -27.4698206841 619.723729023 8.17160013778 -27.4748206841 630.604301844 1.87821927244 -27.4798206841 643.27439323 1.86004193981 -27.4848206841 660.067429252 1.73577259104 -27.4898206841 682.895052823 1.60066140638 -27.4948206841 700.630383637 1.60066140638 -27.4998206841 719.324690191 1.60066140638 -27.5048206841 735.259447102 1.60066140638 -27.5098206841 765.947263529 1.60066140638 -27.5148206841 777.681077487 1.60066140638 -27.5198206841 801.139481069 1.60066140638 -27.5248206841 815.277462876 1.60066140638 -27.5298206841 816.710133515 1.60066140638 -27.5348206841 812.882148964 1.60066140638 -27.5398206841 807.412944464 1.60066140638 -27.5448206841 804.636719071 1.60066140638 -27.5498206841 787.401236236 1.60066140638 -27.5548206841 799.749443797 1.60066140638 -27.5598206841 779.649977469 1.60066140638 -27.5648206841 731.801958426 1.60066140638 -27.5698206841 703.171743452 1.60066140638 -27.5748206841 706.780477239 1.60066140638 -27.5798206841 667.626073297 1.60066140638 -27.5848206841 629.16361644 1.60066140638 -27.5898206841 614.939063713 1.60066140638 -27.5948206841 602.700887314 1.60066140638 -27.5998206841 591.333484032 1.60066140638 -27.6048206841 578.421334657 1.60066140638 -27.6098206841 558.799729162 1.60066140638 -27.6148206841 546.872931367 1.60066140638 -27.6198206841 532.492055453 1.60066140638 -27.6248206841 581.127626302 1.60066140638 -27.6298206841 546.353542204 1.60066140638 -27.6348206841 525.739246333 1.60066140638 -27.6398206841 498.094964929 1.60066140638 -27.6448206841 480.234954159 1.60066140638 -27.6498206841 467.928574656 1.60066140638 -27.6548206841 444.837981322 1.60066140638 -27.6598206841 427.454081678 1.60066140638 -27.6648206841 418.543901996 1.60066140638 -27.6698206841 407.434703415 1.60066140638 -27.6748206841 397.827893657 1.60066140638 -27.6798206841 385.402269681 1.60066140638 -27.6848206841 388.952888054 1.60066140638 -27.6898206841 417.924122621 1.60066140638 -27.6948206841 424.623967192 1.60066140638 -27.6998206841 419.220750186 1.60066140638 -27.7048206841 422.49521912 1.60066140638 -27.7098206841 415.972441883 1.60066140638 -27.7148206841 412.354080865 1.60066140638 -27.7198206841 402.333622539 1.60066140638 -27.7248206841 405.30740682 1.60066140638 -27.7298206841 406.886998759 1.60066140638 -27.7348206841 405.488061879 1.60066140638 -27.7398206841 405.181787859 1.60066140638 -27.7448206841 403.174671872 1.60066140638 -27.7498206841 400.600768459 1.60066140638 -27.7548206841 398.690403682 1.60066140638 -27.7598206841 400.529890431 1.60066140638 -27.7648206841 400.958052518 1.60066140638 -27.7698206841 396.536605836 1.60066140638 -27.7748206841 396.982738183 1.60066140638 -27.7798206841 394.284750513 1.60066140638 -27.7848206841 392.194949435 1.60066140638 -27.7898206841 390.291902883 1.60066140638 -27.7948206841 387.20679193 1.60066140638 -27.7998206841 388.372400082 1.60066140638 -27.8048206841 382.360681078 1.60066140638 -27.8098206841 378.945473138 1.60066140638 -27.8148206841 376.796051161 1.60066140638 -27.8198206841 371.580530492 1.60066140638 -27.8248206841 370.791131555 1.60066140638 -27.8298206841 364.719468784 1.60066140638 -27.8348206841 364.257720436 1.60066140638 -27.8398206841 363.888051901 1.60066140638 -27.8448206841 358.998748835 1.60066140638 -27.8498206841 360.569935054 1.60066140638 -27.8548206841 356.263856479 1.60066140638 -27.8598206841 355.776688119 1.60066140638 -27.8648206841 350.310276971 1.60066140638 -27.8698206841 345.114066767 1.60066140638 -27.8748206841 346.924681434 1.60066140638 -27.8798206841 343.561947001 1.60066140638 -27.8848206841 339.33694175 1.60066140638 -27.8898206841 334.073508808 1.60066140638 -27.8948206841 330.131737921 1.60066140638 -27.8998206841 323.704885421 1.60066140638 -27.9048206841 319.119812766 1.60066140638 -27.9098206841 314.711439892 1.60066140638 -27.9148206841 310.56283664 1.60066140638 -27.9198206841 304.021348987 1.60066140638 -27.9248206841 295.459396552 1.60066140638 -27.9298206841 285.408509376 1.60066140638 -27.9348206841 277.801339119 1.60066140638 -27.9398206841 272.733450821 1.60066140638 -27.9448206841 266.109395334 1.60066140638 -27.9498206841 261.103103192 1.60066140638 -27.9548206841 256.600109955 1.60066140638 -27.9598206841 247.856217122 1.60066140638 -27.9648206841 241.585548787 1.60066140638 -27.9698206841 240.741199201 1.60066140638 -27.9748206841 231.502114158 1.60066140638 -27.9798206841 224.967774461 1.60066140638 -27.9848206841 220.624946569 1.60066140638 -27.9898206841 213.438448205 1.60066140638 -27.9948206841 208.404684952 1.60066140638 -27.9998206841 202.14516962 1.60066140638 diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_mesh005.xls b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_mesh005.xls deleted file mode 100644 index a430a03ffc32..000000000000 Binary files a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/pressure_history_mesh005.xls and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.cnd b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.cnd deleted file mode 100644 index c2b01f166aad..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.cnd +++ /dev/null @@ -1,458 +0,0 @@ -BOOK:Fluid_Boundary_Conditions -NUMBER: 1 CONDITION: point_BODY_FORCE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 2 CONDITION: line_BODY_FORCE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 3 CONDITION: surface_BODY_FORCE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 4 CONDITION: volume_BODY_FORCE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: BODY_FORCE_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: BODY_FORCE_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: BODY_FORCE_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 5 CONDITION: point_VELOCITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 6 CONDITION: line_VELOCITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 7 CONDITION: surface_VELOCITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 8 CONDITION: volume_VELOCITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: VELOCITY_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: VELOCITY_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: VELOCITY_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 9 CONDITION: point_DISPLACEMENT_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 10 CONDITION: line_DISPLACEMENT_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 11 CONDITION: surface_DISPLACEMENT_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 12 CONDITION: volume_DISPLACEMENT_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: DISPLACEMENT_X#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_X,#CURRENT#)(1,RESTORE,Value_X,#CURRENT#) -QUESTION: Value_X -VALUE: 0.0 -QUESTION: DISPLACEMENT_Y#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Y,#CURRENT#)(1,RESTORE,Value_Y,#CURRENT#) -QUESTION: Value_Y -VALUE: 0.0 -QUESTION: DISPLACEMENT_Z#CB#(0,1) -VALUE: 0 -DEPENDENCIES: (0,HIDE,Value_Z,#CURRENT#)(1,RESTORE,Value_Z,#CURRENT#) -QUESTION: Value_Z -VALUE: 0.0 -END CONDITION -NUMBER: 13 CONDITION: point_HEAT_FLUX_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 14 CONDITION: line_HEAT_FLUX_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 15 CONDITION: surface_HEAT_FLUX_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 16 CONDITION: volume_HEAT_FLUX_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 17 CONDITION: point_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 18 CONDITION: line_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 19 CONDITION: surface_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 20 CONDITION: volume_SPECIFIC_HEAT_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 21 CONDITION: point_CONDUCTIVITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 22 CONDITION: line_CONDUCTIVITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 23 CONDITION: surface_CONDUCTIVITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 24 CONDITION: volume_CONDUCTIVITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 25 CONDITION: point_TEMPERATURE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 26 CONDITION: line_TEMPERATURE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 27 CONDITION: surface_TEMPERATURE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 28 CONDITION: volume_TEMPERATURE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 29 CONDITION: point_IS_STRUCTURE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 30 CONDITION: line_IS_STRUCTURE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 31 CONDITION: surface_IS_STRUCTURE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 32 CONDITION: volume_IS_STRUCTURE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 33 CONDITION: point_DENSITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 34 CONDITION: line_DENSITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 35 CONDITION: surface_DENSITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 36 CONDITION: volume_DENSITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 37 CONDITION: point_VISCOSITY_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 38 CONDITION: line_VISCOSITY_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 39 CONDITION: surface_VISCOSITY_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 40 CONDITION: volume_VISCOSITY_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 41 CONDITION: point_PRESSURE_(Fluid) -CONDTYPE: over points -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 42 CONDITION: line_PRESSURE_(Fluid) -CONDTYPE: over lines -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 43 CONDITION: surface_PRESSURE_(Fluid) -CONDTYPE: over surfaces -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -NUMBER: 44 CONDITION: volume_PRESSURE_(Fluid) -CONDTYPE: over volumes -CONDMESHTYPE: over nodes -QUESTION: Value -VALUE: 0.0 -END CONDITION -BOOK:Fluid_Element_Type -NUMBER: 45 CONDITION: volume_ConvDiff3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(ConvDiff3D) -VALUE: ConvDiff3D -END CONDITION -NUMBER: 46 CONDITION: surface_ConvDiff2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(ConvDiff2D) -VALUE: ConvDiff2D -END CONDITION -NUMBER: 47 CONDITION: volume_Fluid3D -CONDTYPE: over volumes -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Fluid3D) -VALUE: Fluid3D -END CONDITION -NUMBER: 48 CONDITION: surface_Fluid2D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Fluid2D) -VALUE: Fluid2D -END CONDITION -NUMBER: 49 CONDITION: surface_Condition3D -CONDTYPE: over surfaces -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Condition3D) -VALUE: Condition3D -END CONDITION -NUMBER: 50 CONDITION: line_Condition2D -CONDTYPE: over lines -CONDMESHTYPE: over body elements -QUESTION: Element_Type#CB#(Condition2D) -VALUE: Condition2D -END CONDITION diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.cond b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.cond deleted file mode 100644 index 6a0424aa9ace..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.cond +++ /dev/null @@ -1,14303 +0,0 @@ - - -// Fixing degrees of freedom in nodes - -NODES[167].Fix(DENSITY); -NODES[168].Fix(DENSITY); -NODES[169].Fix(DENSITY); -NODES[170].Fix(DENSITY); -NODES[171].Fix(DENSITY); -NODES[172].Fix(DENSITY); -NODES[173].Fix(DENSITY); -NODES[174].Fix(DENSITY); -NODES[175].Fix(DENSITY); -NODES[176].Fix(DENSITY); -NODES[177].Fix(DENSITY); -NODES[178].Fix(DENSITY); -NODES[179].Fix(DENSITY); -NODES[184].Fix(DENSITY); -NODES[187].Fix(DENSITY); -NODES[190].Fix(DENSITY); -NODES[195].Fix(DENSITY); -NODES[199].Fix(DENSITY); -NODES[200].Fix(DENSITY); -NODES[207].Fix(DENSITY); -NODES[212].Fix(DENSITY); -NODES[220].Fix(DENSITY); -NODES[225].Fix(DENSITY); -NODES[237].Fix(DENSITY); -NODES[241].Fix(DENSITY); -NODES[251].Fix(DENSITY); -NODES[260].Fix(DENSITY); -NODES[271].Fix(DENSITY); -NODES[281].Fix(DENSITY); -NODES[293].Fix(DENSITY); -NODES[306].Fix(DENSITY); -NODES[321].Fix(DENSITY); -NODES[334].Fix(DENSITY); -NODES[350].Fix(DENSITY); -NODES[364].Fix(DENSITY); -NODES[384].Fix(DENSITY); -NODES[400].Fix(DENSITY); -NODES[417].Fix(DENSITY); -NODES[437].Fix(DENSITY); -NODES[457].Fix(DENSITY); -NODES[479].Fix(DENSITY); -NODES[497].Fix(DENSITY); -NODES[520].Fix(DENSITY); -NODES[540].Fix(DENSITY); -NODES[566].Fix(DENSITY); -NODES[590].Fix(DENSITY); -NODES[615].Fix(DENSITY); -NODES[644].Fix(DENSITY); -NODES[671].Fix(DENSITY); -NODES[702].Fix(DENSITY); -NODES[733].Fix(DENSITY); -NODES[765].Fix(DENSITY); -NODES[796].Fix(DENSITY); -NODES[833].Fix(DENSITY); -NODES[870].Fix(DENSITY); -NODES[907].Fix(DENSITY); -NODES[948].Fix(DENSITY); -NODES[987].Fix(DENSITY); -NODES[1025].Fix(DENSITY); -NODES[1067].Fix(DENSITY); -NODES[1104].Fix(DENSITY); -NODES[1142].Fix(DENSITY); -NODES[1177].Fix(DENSITY); -NODES[1211].Fix(DENSITY); -NODES[1239].Fix(DENSITY); -NODES[1271].Fix(DENSITY); -NODES[1305].Fix(DENSITY); -NODES[1335].Fix(DENSITY); -NODES[1365].Fix(DENSITY); -NODES[1391].Fix(DENSITY); -NODES[1424].Fix(DENSITY); -NODES[1454].Fix(DENSITY); -NODES[1479].Fix(DENSITY); -NODES[1509].Fix(DENSITY); -NODES[1539].Fix(DENSITY); -NODES[1564].Fix(DENSITY); -NODES[1593].Fix(DENSITY); -NODES[1621].Fix(DENSITY); -NODES[1646].Fix(DENSITY); -NODES[1676].Fix(DENSITY); -NODES[1701].Fix(DENSITY); -NODES[1725].Fix(DENSITY); -NODES[1753].Fix(DENSITY); -NODES[1779].Fix(DENSITY); -NODES[1809].Fix(DENSITY); -NODES[1833].Fix(DENSITY); -NODES[1856].Fix(DENSITY); -NODES[1882].Fix(DENSITY); -NODES[1907].Fix(DENSITY); -NODES[1931].Fix(DENSITY); -NODES[1958].Fix(DENSITY); -NODES[1981].Fix(DENSITY); -NODES[2003].Fix(DENSITY); -NODES[2031].Fix(DENSITY); -NODES[2056].Fix(DENSITY); -NODES[2080].Fix(DENSITY); -NODES[2106].Fix(DENSITY); -NODES[2132].Fix(DENSITY); -NODES[2157].Fix(DENSITY); -NODES[2182].Fix(DENSITY); -NODES[2207].Fix(DENSITY); -NODES[2230].Fix(DENSITY); -NODES[2256].Fix(DENSITY); -NODES[2280].Fix(DENSITY); -NODES[2305].Fix(DENSITY); -NODES[2330].Fix(DENSITY); -NODES[2355].Fix(DENSITY); -NODES[2380].Fix(DENSITY); -NODES[2405].Fix(DENSITY); -NODES[2429].Fix(DENSITY); -NODES[2455].Fix(DENSITY); -NODES[2479].Fix(DENSITY); -NODES[2504].Fix(DENSITY); -NODES[2528].Fix(DENSITY); -NODES[2552].Fix(DENSITY); -NODES[2577].Fix(DENSITY); -NODES[2601].Fix(DENSITY); -NODES[2625].Fix(DENSITY); -NODES[2650].Fix(DENSITY); -NODES[2674].Fix(DENSITY); -NODES[2698].Fix(DENSITY); -NODES[2722].Fix(DENSITY); -NODES[2747].Fix(DENSITY); -NODES[2773].Fix(DENSITY); -NODES[2796].Fix(DENSITY); -NODES[2819].Fix(DENSITY); -NODES[2844].Fix(DENSITY); -NODES[2867].Fix(DENSITY); -NODES[2892].Fix(DENSITY); -NODES[2917].Fix(DENSITY); -NODES[2941].Fix(DENSITY); -NODES[2965].Fix(DENSITY); -NODES[2988].Fix(DENSITY); -NODES[3013].Fix(DENSITY); -NODES[3037].Fix(DENSITY); -NODES[3061].Fix(DENSITY); -NODES[3085].Fix(DENSITY); -NODES[3110].Fix(DENSITY); -NODES[3133].Fix(DENSITY); -NODES[3157].Fix(DENSITY); -NODES[3181].Fix(DENSITY); -NODES[3204].Fix(DENSITY); -NODES[3227].Fix(DENSITY); -NODES[3249].Fix(DENSITY); -NODES[3273].Fix(DENSITY); -NODES[3297].Fix(DENSITY); -NODES[3321].Fix(DENSITY); -NODES[3343].Fix(DENSITY); -NODES[3368].Fix(DENSITY); -NODES[3392].Fix(DENSITY); -NODES[3416].Fix(DENSITY); -NODES[3440].Fix(DENSITY); -NODES[3464].Fix(DENSITY); -NODES[3488].Fix(DENSITY); -NODES[3510].Fix(DENSITY); -NODES[3534].Fix(DENSITY); -NODES[3558].Fix(DENSITY); -NODES[3582].Fix(DENSITY); -NODES[3605].Fix(DENSITY); -NODES[3629].Fix(DENSITY); -NODES[3662].Fix(DENSITY); -NODES[3696].Fix(DENSITY); -NODES[3726].Fix(DENSITY); -NODES[3753].Fix(DENSITY); -NODES[3779].Fix(DENSITY); -NODES[3806].Fix(DENSITY); -NODES[3832].Fix(DENSITY); -NODES[3856].Fix(DENSITY); -NODES[3881].Fix(DENSITY); -NODES[3907].Fix(DENSITY); -NODES[3935].Fix(DENSITY); -NODES[3958].Fix(DENSITY); -NODES[3985].Fix(DENSITY); -NODES[4009].Fix(DENSITY); -NODES[4034].Fix(DENSITY); -NODES[4059].Fix(DENSITY); -NODES[4083].Fix(DENSITY); -NODES[4110].Fix(DENSITY); -NODES[4133].Fix(DENSITY); -NODES[4160].Fix(DENSITY); -NODES[4186].Fix(DENSITY); -NODES[1].Fix(IS_STRUCTURE); -NODES[2].Fix(IS_STRUCTURE); -NODES[3].Fix(IS_STRUCTURE); -NODES[4].Fix(IS_STRUCTURE); -NODES[5].Fix(IS_STRUCTURE); -NODES[6].Fix(IS_STRUCTURE); -NODES[7].Fix(IS_STRUCTURE); -NODES[8].Fix(IS_STRUCTURE); -NODES[9].Fix(IS_STRUCTURE); -NODES[10].Fix(IS_STRUCTURE); -NODES[11].Fix(IS_STRUCTURE); -NODES[12].Fix(IS_STRUCTURE); -NODES[13].Fix(IS_STRUCTURE); -NODES[14].Fix(IS_STRUCTURE); -NODES[15].Fix(IS_STRUCTURE); -NODES[16].Fix(IS_STRUCTURE); -NODES[17].Fix(IS_STRUCTURE); -NODES[18].Fix(IS_STRUCTURE); -NODES[19].Fix(IS_STRUCTURE); -NODES[20].Fix(IS_STRUCTURE); -NODES[21].Fix(IS_STRUCTURE); -NODES[22].Fix(IS_STRUCTURE); -NODES[23].Fix(IS_STRUCTURE); -NODES[24].Fix(IS_STRUCTURE); -NODES[25].Fix(IS_STRUCTURE); -NODES[26].Fix(IS_STRUCTURE); -NODES[27].Fix(IS_STRUCTURE); -NODES[28].Fix(IS_STRUCTURE); -NODES[29].Fix(IS_STRUCTURE); -NODES[30].Fix(IS_STRUCTURE); -NODES[31].Fix(IS_STRUCTURE); -NODES[32].Fix(IS_STRUCTURE); -NODES[33].Fix(IS_STRUCTURE); -NODES[34].Fix(IS_STRUCTURE); -NODES[35].Fix(IS_STRUCTURE); -NODES[36].Fix(IS_STRUCTURE); -NODES[37].Fix(IS_STRUCTURE); -NODES[38].Fix(IS_STRUCTURE); -NODES[39].Fix(IS_STRUCTURE); -NODES[40].Fix(IS_STRUCTURE); -NODES[41].Fix(IS_STRUCTURE); -NODES[42].Fix(IS_STRUCTURE); -NODES[43].Fix(IS_STRUCTURE); -NODES[44].Fix(IS_STRUCTURE); -NODES[45].Fix(IS_STRUCTURE); -NODES[46].Fix(IS_STRUCTURE); -NODES[47].Fix(IS_STRUCTURE); -NODES[48].Fix(IS_STRUCTURE); -NODES[49].Fix(IS_STRUCTURE); -NODES[50].Fix(IS_STRUCTURE); -NODES[51].Fix(IS_STRUCTURE); -NODES[52].Fix(IS_STRUCTURE); -NODES[53].Fix(IS_STRUCTURE); -NODES[54].Fix(IS_STRUCTURE); -NODES[55].Fix(IS_STRUCTURE); -NODES[56].Fix(IS_STRUCTURE); -NODES[57].Fix(IS_STRUCTURE); -NODES[58].Fix(IS_STRUCTURE); -NODES[59].Fix(IS_STRUCTURE); -NODES[60].Fix(IS_STRUCTURE); -NODES[61].Fix(IS_STRUCTURE); -NODES[62].Fix(IS_STRUCTURE); -NODES[63].Fix(IS_STRUCTURE); -NODES[64].Fix(IS_STRUCTURE); -NODES[65].Fix(IS_STRUCTURE); -NODES[66].Fix(IS_STRUCTURE); -NODES[67].Fix(IS_STRUCTURE); -NODES[68].Fix(IS_STRUCTURE); -NODES[69].Fix(IS_STRUCTURE); -NODES[70].Fix(IS_STRUCTURE); -NODES[71].Fix(IS_STRUCTURE); -NODES[72].Fix(IS_STRUCTURE); -NODES[73].Fix(IS_STRUCTURE); -NODES[74].Fix(IS_STRUCTURE); -NODES[75].Fix(IS_STRUCTURE); -NODES[76].Fix(IS_STRUCTURE); -NODES[77].Fix(IS_STRUCTURE); -NODES[78].Fix(IS_STRUCTURE); -NODES[79].Fix(IS_STRUCTURE); -NODES[80].Fix(IS_STRUCTURE); -NODES[81].Fix(IS_STRUCTURE); -NODES[82].Fix(IS_STRUCTURE); -NODES[83].Fix(IS_STRUCTURE); -NODES[84].Fix(IS_STRUCTURE); -NODES[85].Fix(IS_STRUCTURE); -NODES[86].Fix(IS_STRUCTURE); -NODES[87].Fix(IS_STRUCTURE); -NODES[88].Fix(IS_STRUCTURE); -NODES[89].Fix(IS_STRUCTURE); -NODES[90].Fix(IS_STRUCTURE); -NODES[91].Fix(IS_STRUCTURE); -NODES[92].Fix(IS_STRUCTURE); -NODES[93].Fix(IS_STRUCTURE); -NODES[94].Fix(IS_STRUCTURE); -NODES[95].Fix(IS_STRUCTURE); -NODES[96].Fix(IS_STRUCTURE); -NODES[97].Fix(IS_STRUCTURE); -NODES[98].Fix(IS_STRUCTURE); -NODES[99].Fix(IS_STRUCTURE); -NODES[100].Fix(IS_STRUCTURE); -NODES[101].Fix(IS_STRUCTURE); -NODES[102].Fix(IS_STRUCTURE); -NODES[103].Fix(IS_STRUCTURE); -NODES[104].Fix(IS_STRUCTURE); -NODES[105].Fix(IS_STRUCTURE); -NODES[106].Fix(IS_STRUCTURE); -NODES[107].Fix(IS_STRUCTURE); -NODES[108].Fix(IS_STRUCTURE); -NODES[109].Fix(IS_STRUCTURE); -NODES[110].Fix(IS_STRUCTURE); -NODES[111].Fix(IS_STRUCTURE); -NODES[112].Fix(IS_STRUCTURE); -NODES[113].Fix(IS_STRUCTURE); -NODES[114].Fix(IS_STRUCTURE); -NODES[115].Fix(IS_STRUCTURE); -NODES[116].Fix(IS_STRUCTURE); -NODES[117].Fix(IS_STRUCTURE); -NODES[118].Fix(IS_STRUCTURE); -NODES[119].Fix(IS_STRUCTURE); -NODES[120].Fix(IS_STRUCTURE); -NODES[121].Fix(IS_STRUCTURE); -NODES[122].Fix(IS_STRUCTURE); -NODES[123].Fix(IS_STRUCTURE); -NODES[124].Fix(IS_STRUCTURE); -NODES[125].Fix(IS_STRUCTURE); -NODES[126].Fix(IS_STRUCTURE); -NODES[127].Fix(IS_STRUCTURE); -NODES[128].Fix(IS_STRUCTURE); -NODES[129].Fix(IS_STRUCTURE); -NODES[130].Fix(IS_STRUCTURE); -NODES[131].Fix(IS_STRUCTURE); -NODES[132].Fix(IS_STRUCTURE); -NODES[133].Fix(IS_STRUCTURE); -NODES[134].Fix(IS_STRUCTURE); -NODES[135].Fix(IS_STRUCTURE); -NODES[136].Fix(IS_STRUCTURE); -NODES[137].Fix(IS_STRUCTURE); -NODES[138].Fix(IS_STRUCTURE); -NODES[139].Fix(IS_STRUCTURE); -NODES[140].Fix(IS_STRUCTURE); -NODES[141].Fix(IS_STRUCTURE); -NODES[142].Fix(IS_STRUCTURE); -NODES[143].Fix(IS_STRUCTURE); -NODES[144].Fix(IS_STRUCTURE); -NODES[145].Fix(IS_STRUCTURE); -NODES[146].Fix(IS_STRUCTURE); -NODES[147].Fix(IS_STRUCTURE); -NODES[148].Fix(IS_STRUCTURE); -NODES[149].Fix(IS_STRUCTURE); -NODES[150].Fix(IS_STRUCTURE); -NODES[151].Fix(IS_STRUCTURE); -NODES[152].Fix(IS_STRUCTURE); -NODES[153].Fix(IS_STRUCTURE); -NODES[154].Fix(IS_STRUCTURE); -NODES[155].Fix(IS_STRUCTURE); -NODES[156].Fix(IS_STRUCTURE); -NODES[157].Fix(IS_STRUCTURE); -NODES[158].Fix(IS_STRUCTURE); -NODES[159].Fix(IS_STRUCTURE); -NODES[160].Fix(IS_STRUCTURE); -NODES[161].Fix(IS_STRUCTURE); -NODES[162].Fix(IS_STRUCTURE); -NODES[163].Fix(IS_STRUCTURE); -NODES[164].Fix(IS_STRUCTURE); -NODES[165].Fix(IS_STRUCTURE); -NODES[166].Fix(IS_STRUCTURE); -NODES[167].Fix(IS_STRUCTURE); -NODES[181].Fix(IS_STRUCTURE); -NODES[183].Fix(IS_STRUCTURE); -NODES[202].Fix(IS_STRUCTURE); -NODES[204].Fix(IS_STRUCTURE); -NODES[228].Fix(IS_STRUCTURE); -NODES[231].Fix(IS_STRUCTURE); -NODES[257].Fix(IS_STRUCTURE); -NODES[261].Fix(IS_STRUCTURE); -NODES[291].Fix(IS_STRUCTURE); -NODES[299].Fix(IS_STRUCTURE); -NODES[329].Fix(IS_STRUCTURE); -NODES[337].Fix(IS_STRUCTURE); -NODES[371].Fix(IS_STRUCTURE); -NODES[381].Fix(IS_STRUCTURE); -NODES[414].Fix(IS_STRUCTURE); -NODES[425].Fix(IS_STRUCTURE); -NODES[462].Fix(IS_STRUCTURE); -NODES[470].Fix(IS_STRUCTURE); -NODES[505].Fix(IS_STRUCTURE); -NODES[518].Fix(IS_STRUCTURE); -NODES[557].Fix(IS_STRUCTURE); -NODES[570].Fix(IS_STRUCTURE); -NODES[607].Fix(IS_STRUCTURE); -NODES[622].Fix(IS_STRUCTURE); -NODES[663].Fix(IS_STRUCTURE); -NODES[677].Fix(IS_STRUCTURE); -NODES[721].Fix(IS_STRUCTURE); -NODES[738].Fix(IS_STRUCTURE); -NODES[781].Fix(IS_STRUCTURE); -NODES[802].Fix(IS_STRUCTURE); -NODES[845].Fix(IS_STRUCTURE); -NODES[867].Fix(IS_STRUCTURE); -NODES[912].Fix(IS_STRUCTURE); -NODES[938].Fix(IS_STRUCTURE); -NODES[983].Fix(IS_STRUCTURE); -NODES[1009].Fix(IS_STRUCTURE); -NODES[1048].Fix(IS_STRUCTURE); -NODES[1049].Fix(IS_STRUCTURE); -NODES[1051].Fix(IS_STRUCTURE); -NODES[1054].Fix(IS_STRUCTURE); -NODES[1057].Fix(IS_STRUCTURE); -NODES[1061].Fix(IS_STRUCTURE); -NODES[1062].Fix(IS_STRUCTURE); -NODES[1068].Fix(IS_STRUCTURE); -NODES[1070].Fix(IS_STRUCTURE); -NODES[1079].Fix(IS_STRUCTURE); -NODES[1080].Fix(IS_STRUCTURE); -NODES[1086].Fix(IS_STRUCTURE); -NODES[1095].Fix(IS_STRUCTURE); -NODES[1101].Fix(IS_STRUCTURE); -NODES[1105].Fix(IS_STRUCTURE); -NODES[1115].Fix(IS_STRUCTURE); -NODES[1126].Fix(IS_STRUCTURE); -NODES[1132].Fix(IS_STRUCTURE); -NODES[1140].Fix(IS_STRUCTURE); -NODES[1143].Fix(IS_STRUCTURE); -NODES[1152].Fix(IS_STRUCTURE); -NODES[1162].Fix(IS_STRUCTURE); -NODES[1173].Fix(IS_STRUCTURE); -NODES[1184].Fix(IS_STRUCTURE); -NODES[1194].Fix(IS_STRUCTURE); -NODES[1200].Fix(IS_STRUCTURE); -NODES[1207].Fix(IS_STRUCTURE); -NODES[1218].Fix(IS_STRUCTURE); -NODES[1233].Fix(IS_STRUCTURE); -NODES[1244].Fix(IS_STRUCTURE); -NODES[1252].Fix(IS_STRUCTURE); -NODES[1258].Fix(IS_STRUCTURE); -NODES[1269].Fix(IS_STRUCTURE); -NODES[1287].Fix(IS_STRUCTURE); -NODES[1296].Fix(IS_STRUCTURE); -NODES[1301].Fix(IS_STRUCTURE); -NODES[1314].Fix(IS_STRUCTURE); -NODES[1327].Fix(IS_STRUCTURE); -NODES[1342].Fix(IS_STRUCTURE); -NODES[1349].Fix(IS_STRUCTURE); -NODES[1356].Fix(IS_STRUCTURE); -NODES[1370].Fix(IS_STRUCTURE); -NODES[1386].Fix(IS_STRUCTURE); -NODES[1396].Fix(IS_STRUCTURE); -NODES[1403].Fix(IS_STRUCTURE); -NODES[1416].Fix(IS_STRUCTURE); -NODES[1434].Fix(IS_STRUCTURE); -NODES[1441].Fix(IS_STRUCTURE); -NODES[1452].Fix(IS_STRUCTURE); -NODES[1467].Fix(IS_STRUCTURE); -NODES[1480].Fix(IS_STRUCTURE); -NODES[1485].Fix(IS_STRUCTURE); -NODES[1500].Fix(IS_STRUCTURE); -NODES[1517].Fix(IS_STRUCTURE); -NODES[1527].Fix(IS_STRUCTURE); -NODES[1534].Fix(IS_STRUCTURE); -NODES[1550].Fix(IS_STRUCTURE); -NODES[1566].Fix(IS_STRUCTURE); -NODES[1571].Fix(IS_STRUCTURE); -NODES[1584].Fix(IS_STRUCTURE); -NODES[1602].Fix(IS_STRUCTURE); -NODES[1611].Fix(IS_STRUCTURE); -NODES[1622].Fix(IS_STRUCTURE); -NODES[1639].Fix(IS_STRUCTURE); -NODES[1651].Fix(IS_STRUCTURE); -NODES[1656].Fix(IS_STRUCTURE); -NODES[1677].Fix(IS_STRUCTURE); -NODES[1690].Fix(IS_STRUCTURE); -NODES[1693].Fix(IS_STRUCTURE); -NODES[1712].Fix(IS_STRUCTURE); -NODES[1729].Fix(IS_STRUCTURE); -NODES[1730].Fix(IS_STRUCTURE); -NODES[1747].Fix(IS_STRUCTURE); -NODES[1765].Fix(IS_STRUCTURE); -NODES[1767].Fix(IS_STRUCTURE); -NODES[1784].Fix(IS_STRUCTURE); -NODES[1803].Fix(IS_STRUCTURE); -NODES[1804].Fix(IS_STRUCTURE); -NODES[1822].Fix(IS_STRUCTURE); -NODES[1839].Fix(IS_STRUCTURE); -NODES[1840].Fix(IS_STRUCTURE); -NODES[1857].Fix(IS_STRUCTURE); -NODES[1873].Fix(IS_STRUCTURE); -NODES[1876].Fix(IS_STRUCTURE); -NODES[1894].Fix(IS_STRUCTURE); -NODES[1909].Fix(IS_STRUCTURE); -NODES[1913].Fix(IS_STRUCTURE); -NODES[1932].Fix(IS_STRUCTURE); -NODES[1943].Fix(IS_STRUCTURE); -NODES[1950].Fix(IS_STRUCTURE); -NODES[1969].Fix(IS_STRUCTURE); -NODES[1975].Fix(IS_STRUCTURE); -NODES[1988].Fix(IS_STRUCTURE); -NODES[2008].Fix(IS_STRUCTURE); -NODES[2010].Fix(IS_STRUCTURE); -NODES[2025].Fix(IS_STRUCTURE); -NODES[2043].Fix(IS_STRUCTURE); -NODES[2045].Fix(IS_STRUCTURE); -NODES[2064].Fix(IS_STRUCTURE); -NODES[2077].Fix(IS_STRUCTURE); -NODES[2086].Fix(IS_STRUCTURE); -NODES[2102].Fix(IS_STRUCTURE); -NODES[2110].Fix(IS_STRUCTURE); -NODES[2124].Fix(IS_STRUCTURE); -NODES[2143].Fix(IS_STRUCTURE); -NODES[2144].Fix(IS_STRUCTURE); -NODES[2166].Fix(IS_STRUCTURE); -NODES[2176].Fix(IS_STRUCTURE); -NODES[2186].Fix(IS_STRUCTURE); -NODES[2205].Fix(IS_STRUCTURE); -NODES[2208].Fix(IS_STRUCTURE); -NODES[2226].Fix(IS_STRUCTURE); -NODES[2240].Fix(IS_STRUCTURE); -NODES[2246].Fix(IS_STRUCTURE); -NODES[2267].Fix(IS_STRUCTURE); -NODES[2272].Fix(IS_STRUCTURE); -NODES[2287].Fix(IS_STRUCTURE); -NODES[2303].Fix(IS_STRUCTURE); -NODES[2308].Fix(IS_STRUCTURE); -NODES[2326].Fix(IS_STRUCTURE); -NODES[2336].Fix(IS_STRUCTURE); -NODES[2349].Fix(IS_STRUCTURE); -NODES[2367].Fix(IS_STRUCTURE); -NODES[2369].Fix(IS_STRUCTURE); -NODES[2389].Fix(IS_STRUCTURE); -NODES[2397].Fix(IS_STRUCTURE); -NODES[2411].Fix(IS_STRUCTURE); -NODES[2428].Fix(IS_STRUCTURE); -NODES[2433].Fix(IS_STRUCTURE); -NODES[2451].Fix(IS_STRUCTURE); -NODES[2462].Fix(IS_STRUCTURE); -NODES[2472].Fix(IS_STRUCTURE); -NODES[2492].Fix(IS_STRUCTURE); -NODES[2494].Fix(IS_STRUCTURE); -NODES[2515].Fix(IS_STRUCTURE); -NODES[2522].Fix(IS_STRUCTURE); -NODES[2537].Fix(IS_STRUCTURE); -NODES[2551].Fix(IS_STRUCTURE); -NODES[2557].Fix(IS_STRUCTURE); -NODES[2578].Fix(IS_STRUCTURE); -NODES[2582].Fix(IS_STRUCTURE); -NODES[2598].Fix(IS_STRUCTURE); -NODES[2612].Fix(IS_STRUCTURE); -NODES[2620].Fix(IS_STRUCTURE); -NODES[2640].Fix(IS_STRUCTURE); -NODES[2642].Fix(IS_STRUCTURE); -NODES[2662].Fix(IS_STRUCTURE); -NODES[2671].Fix(IS_STRUCTURE); -NODES[2684].Fix(IS_STRUCTURE); -NODES[2702].Fix(IS_STRUCTURE); -NODES[2705].Fix(IS_STRUCTURE); -NODES[2725].Fix(IS_STRUCTURE); -NODES[2731].Fix(IS_STRUCTURE); -NODES[2746].Fix(IS_STRUCTURE); -NODES[2760].Fix(IS_STRUCTURE); -NODES[2767].Fix(IS_STRUCTURE); -NODES[2788].Fix(IS_STRUCTURE); -NODES[2789].Fix(IS_STRUCTURE); -NODES[2811].Fix(IS_STRUCTURE); -NODES[2817].Fix(IS_STRUCTURE); -NODES[2832].Fix(IS_STRUCTURE); -NODES[2848].Fix(IS_STRUCTURE); -NODES[2855].Fix(IS_STRUCTURE); -NODES[2876].Fix(IS_STRUCTURE); -NODES[2878].Fix(IS_STRUCTURE); -NODES[2896].Fix(IS_STRUCTURE); -NODES[2905].Fix(IS_STRUCTURE); -NODES[2918].Fix(IS_STRUCTURE); -NODES[2932].Fix(IS_STRUCTURE); -NODES[2939].Fix(IS_STRUCTURE); -NODES[2959].Fix(IS_STRUCTURE); -NODES[2962].Fix(IS_STRUCTURE); -NODES[2981].Fix(IS_STRUCTURE); -NODES[2991].Fix(IS_STRUCTURE); -NODES[3004].Fix(IS_STRUCTURE); -NODES[3020].Fix(IS_STRUCTURE); -NODES[3026].Fix(IS_STRUCTURE); -NODES[3048].Fix(IS_STRUCTURE); -NODES[3049].Fix(IS_STRUCTURE); -NODES[3069].Fix(IS_STRUCTURE); -NODES[3075].Fix(IS_STRUCTURE); -NODES[3091].Fix(IS_STRUCTURE); -NODES[3102].Fix(IS_STRUCTURE); -NODES[3114].Fix(IS_STRUCTURE); -NODES[3131].Fix(IS_STRUCTURE); -NODES[3136].Fix(IS_STRUCTURE); -NODES[3156].Fix(IS_STRUCTURE); -NODES[3161].Fix(IS_STRUCTURE); -NODES[3174].Fix(IS_STRUCTURE); -NODES[3188].Fix(IS_STRUCTURE); -NODES[3196].Fix(IS_STRUCTURE); -NODES[3215].Fix(IS_STRUCTURE); -NODES[3219].Fix(IS_STRUCTURE); -NODES[3241].Fix(IS_STRUCTURE); -NODES[3242].Fix(IS_STRUCTURE); -NODES[3263].Fix(IS_STRUCTURE); -NODES[3267].Fix(IS_STRUCTURE); -NODES[3286].Fix(IS_STRUCTURE); -NODES[3292].Fix(IS_STRUCTURE); -NODES[3308].Fix(IS_STRUCTURE); -NODES[3323].Fix(IS_STRUCTURE); -NODES[3328].Fix(IS_STRUCTURE); -NODES[3348].Fix(IS_STRUCTURE); -NODES[3349].Fix(IS_STRUCTURE); -NODES[3370].Fix(IS_STRUCTURE); -NODES[3375].Fix(IS_STRUCTURE); -NODES[3393].Fix(IS_STRUCTURE); -NODES[3401].Fix(IS_STRUCTURE); -NODES[3414].Fix(IS_STRUCTURE); -NODES[3426].Fix(IS_STRUCTURE); -NODES[3436].Fix(IS_STRUCTURE); -NODES[3457].Fix(IS_STRUCTURE); -NODES[3459].Fix(IS_STRUCTURE); -NODES[3477].Fix(IS_STRUCTURE); -NODES[3485].Fix(IS_STRUCTURE); -NODES[3495].Fix(IS_STRUCTURE); -NODES[3512].Fix(IS_STRUCTURE); -NODES[3518].Fix(IS_STRUCTURE); -NODES[3538].Fix(IS_STRUCTURE); -NODES[3541].Fix(IS_STRUCTURE); -NODES[3563].Fix(IS_STRUCTURE); -NODES[3564].Fix(IS_STRUCTURE); -NODES[3586].Fix(IS_STRUCTURE); -NODES[3587].Fix(IS_STRUCTURE); -NODES[3609].Fix(IS_STRUCTURE); -NODES[3617].Fix(IS_STRUCTURE); -NODES[3632].Fix(IS_STRUCTURE); -NODES[3648].Fix(IS_STRUCTURE); -NODES[3649].Fix(IS_STRUCTURE); -NODES[3650].Fix(IS_STRUCTURE); -NODES[3651].Fix(IS_STRUCTURE); -NODES[3653].Fix(IS_STRUCTURE); -NODES[3654].Fix(IS_STRUCTURE); -NODES[3656].Fix(IS_STRUCTURE); -NODES[3657].Fix(IS_STRUCTURE); -NODES[3659].Fix(IS_STRUCTURE); -NODES[3661].Fix(IS_STRUCTURE); -NODES[3664].Fix(IS_STRUCTURE); -NODES[3665].Fix(IS_STRUCTURE); -NODES[3666].Fix(IS_STRUCTURE); -NODES[3667].Fix(IS_STRUCTURE); -NODES[3668].Fix(IS_STRUCTURE); -NODES[3669].Fix(IS_STRUCTURE); -NODES[3670].Fix(IS_STRUCTURE); -NODES[3671].Fix(IS_STRUCTURE); -NODES[3683].Fix(IS_STRUCTURE); -NODES[3689].Fix(IS_STRUCTURE); -NODES[3692].Fix(IS_STRUCTURE); -NODES[3694].Fix(IS_STRUCTURE); -NODES[3697].Fix(IS_STRUCTURE); -NODES[3698].Fix(IS_STRUCTURE); -NODES[3699].Fix(IS_STRUCTURE); -NODES[3700].Fix(IS_STRUCTURE); -NODES[3705].Fix(IS_STRUCTURE); -NODES[3716].Fix(IS_STRUCTURE); -NODES[3721].Fix(IS_STRUCTURE); -NODES[3724].Fix(IS_STRUCTURE); -NODES[3725].Fix(IS_STRUCTURE); -NODES[3727].Fix(IS_STRUCTURE); -NODES[3729].Fix(IS_STRUCTURE); -NODES[3735].Fix(IS_STRUCTURE); -NODES[3745].Fix(IS_STRUCTURE); -NODES[3750].Fix(IS_STRUCTURE); -NODES[3751].Fix(IS_STRUCTURE); -NODES[3754].Fix(IS_STRUCTURE); -NODES[3755].Fix(IS_STRUCTURE); -NODES[3765].Fix(IS_STRUCTURE); -NODES[3774].Fix(IS_STRUCTURE); -NODES[3777].Fix(IS_STRUCTURE); -NODES[3778].Fix(IS_STRUCTURE); -NODES[3782].Fix(IS_STRUCTURE); -NODES[3783].Fix(IS_STRUCTURE); -NODES[3799].Fix(IS_STRUCTURE); -NODES[3803].Fix(IS_STRUCTURE); -NODES[3805].Fix(IS_STRUCTURE); -NODES[3807].Fix(IS_STRUCTURE); -NODES[3810].Fix(IS_STRUCTURE); -NODES[3824].Fix(IS_STRUCTURE); -NODES[3826].Fix(IS_STRUCTURE); -NODES[3831].Fix(IS_STRUCTURE); -NODES[3833].Fix(IS_STRUCTURE); -NODES[3843].Fix(IS_STRUCTURE); -NODES[3851].Fix(IS_STRUCTURE); -NODES[3852].Fix(IS_STRUCTURE); -NODES[3857].Fix(IS_STRUCTURE); -NODES[3862].Fix(IS_STRUCTURE); -NODES[3874].Fix(IS_STRUCTURE); -NODES[3875].Fix(IS_STRUCTURE); -NODES[3879].Fix(IS_STRUCTURE); -NODES[3888].Fix(IS_STRUCTURE); -NODES[3898].Fix(IS_STRUCTURE); -NODES[3900].Fix(IS_STRUCTURE); -NODES[3905].Fix(IS_STRUCTURE); -NODES[3912].Fix(IS_STRUCTURE); -NODES[3919].Fix(IS_STRUCTURE); -NODES[3923].Fix(IS_STRUCTURE); -NODES[3931].Fix(IS_STRUCTURE); -NODES[3939].Fix(IS_STRUCTURE); -NODES[3945].Fix(IS_STRUCTURE); -NODES[3950].Fix(IS_STRUCTURE); -NODES[3957].Fix(IS_STRUCTURE); -NODES[3965].Fix(IS_STRUCTURE); -NODES[3968].Fix(IS_STRUCTURE); -NODES[3976].Fix(IS_STRUCTURE); -NODES[3986].Fix(IS_STRUCTURE); -NODES[3990].Fix(IS_STRUCTURE); -NODES[3995].Fix(IS_STRUCTURE); -NODES[4003].Fix(IS_STRUCTURE); -NODES[4014].Fix(IS_STRUCTURE); -NODES[4015].Fix(IS_STRUCTURE); -NODES[4024].Fix(IS_STRUCTURE); -NODES[4033].Fix(IS_STRUCTURE); -NODES[4039].Fix(IS_STRUCTURE); -NODES[4044].Fix(IS_STRUCTURE); -NODES[4053].Fix(IS_STRUCTURE); -NODES[4061].Fix(IS_STRUCTURE); -NODES[4065].Fix(IS_STRUCTURE); -NODES[4072].Fix(IS_STRUCTURE); -NODES[4086].Fix(IS_STRUCTURE); -NODES[4087].Fix(IS_STRUCTURE); -NODES[4094].Fix(IS_STRUCTURE); -NODES[4106].Fix(IS_STRUCTURE); -NODES[4109].Fix(IS_STRUCTURE); -NODES[4118].Fix(IS_STRUCTURE); -NODES[4128].Fix(IS_STRUCTURE); -NODES[4132].Fix(IS_STRUCTURE); -NODES[4139].Fix(IS_STRUCTURE); -NODES[4149].Fix(IS_STRUCTURE); -NODES[4157].Fix(IS_STRUCTURE); -NODES[4163].Fix(IS_STRUCTURE); -NODES[4173].Fix(IS_STRUCTURE); -NODES[4180].Fix(IS_STRUCTURE); -NODES[4186].Fix(IS_STRUCTURE); -NODES[4196].Fix(IS_STRUCTURE); -NODES[4201].Fix(IS_STRUCTURE); -NODES[4207].Fix(IS_STRUCTURE); -NODES[4214].Fix(IS_STRUCTURE); -NODES[4222].Fix(IS_STRUCTURE); -NODES[4226].Fix(IS_STRUCTURE); -NODES[4234].Fix(IS_STRUCTURE); -NODES[4240].Fix(IS_STRUCTURE); -NODES[4242].Fix(IS_STRUCTURE); -NODES[4248].Fix(IS_STRUCTURE); -NODES[4255].Fix(IS_STRUCTURE); -NODES[4257].Fix(IS_STRUCTURE); -NODES[4263].Fix(IS_STRUCTURE); -NODES[4268].Fix(IS_STRUCTURE); -NODES[4270].Fix(IS_STRUCTURE); -NODES[4275].Fix(IS_STRUCTURE); -NODES[4276].Fix(IS_STRUCTURE); -NODES[4281].Fix(IS_STRUCTURE); -NODES[4284].Fix(IS_STRUCTURE); -NODES[4286].Fix(IS_STRUCTURE); -NODES[4289].Fix(IS_STRUCTURE); -NODES[4292].Fix(IS_STRUCTURE); -NODES[4293].Fix(IS_STRUCTURE); -NODES[4295].Fix(IS_STRUCTURE); -NODES[4296].Fix(IS_STRUCTURE); -NODES[4297].Fix(IS_STRUCTURE); -NODES[4298].Fix(IS_STRUCTURE); -NODES[4299].Fix(IS_STRUCTURE); -NODES[1].Fix(VELOCITY_X); -NODES[1].Fix(VELOCITY_Y); -NODES[1].Fix(VELOCITY_Z); -NODES[2].Fix(VELOCITY_X); -NODES[2].Fix(VELOCITY_Y); -NODES[2].Fix(VELOCITY_Z); -NODES[3].Fix(VELOCITY_X); -NODES[3].Fix(VELOCITY_Y); -NODES[3].Fix(VELOCITY_Z); -NODES[4].Fix(VELOCITY_X); -NODES[4].Fix(VELOCITY_Y); -NODES[4].Fix(VELOCITY_Z); -NODES[5].Fix(VELOCITY_X); -NODES[5].Fix(VELOCITY_Y); -NODES[5].Fix(VELOCITY_Z); -NODES[6].Fix(VELOCITY_X); -NODES[6].Fix(VELOCITY_Y); -NODES[6].Fix(VELOCITY_Z); -NODES[7].Fix(VELOCITY_X); -NODES[7].Fix(VELOCITY_Y); -NODES[7].Fix(VELOCITY_Z); -NODES[8].Fix(VELOCITY_X); -NODES[8].Fix(VELOCITY_Y); -NODES[8].Fix(VELOCITY_Z); -NODES[9].Fix(VELOCITY_X); -NODES[9].Fix(VELOCITY_Y); -NODES[9].Fix(VELOCITY_Z); -NODES[10].Fix(VELOCITY_X); -NODES[10].Fix(VELOCITY_Y); -NODES[10].Fix(VELOCITY_Z); -NODES[11].Fix(VELOCITY_X); -NODES[11].Fix(VELOCITY_Y); -NODES[11].Fix(VELOCITY_Z); -NODES[12].Fix(VELOCITY_X); -NODES[12].Fix(VELOCITY_Y); -NODES[12].Fix(VELOCITY_Z); -NODES[13].Fix(VELOCITY_X); -NODES[13].Fix(VELOCITY_Y); -NODES[13].Fix(VELOCITY_Z); -NODES[14].Fix(VELOCITY_X); -NODES[14].Fix(VELOCITY_Y); -NODES[14].Fix(VELOCITY_Z); -NODES[15].Fix(VELOCITY_X); -NODES[15].Fix(VELOCITY_Y); -NODES[15].Fix(VELOCITY_Z); -NODES[16].Fix(VELOCITY_X); -NODES[16].Fix(VELOCITY_Y); -NODES[16].Fix(VELOCITY_Z); -NODES[17].Fix(VELOCITY_X); -NODES[17].Fix(VELOCITY_Y); -NODES[17].Fix(VELOCITY_Z); -NODES[18].Fix(VELOCITY_X); -NODES[18].Fix(VELOCITY_Y); -NODES[18].Fix(VELOCITY_Z); -NODES[19].Fix(VELOCITY_X); -NODES[19].Fix(VELOCITY_Y); -NODES[19].Fix(VELOCITY_Z); -NODES[20].Fix(VELOCITY_X); -NODES[20].Fix(VELOCITY_Y); -NODES[20].Fix(VELOCITY_Z); -NODES[21].Fix(VELOCITY_X); -NODES[21].Fix(VELOCITY_Y); -NODES[21].Fix(VELOCITY_Z); -NODES[22].Fix(VELOCITY_X); -NODES[22].Fix(VELOCITY_Y); -NODES[22].Fix(VELOCITY_Z); -NODES[23].Fix(VELOCITY_X); -NODES[23].Fix(VELOCITY_Y); -NODES[23].Fix(VELOCITY_Z); -NODES[24].Fix(VELOCITY_X); -NODES[24].Fix(VELOCITY_Y); -NODES[24].Fix(VELOCITY_Z); -NODES[25].Fix(VELOCITY_X); -NODES[25].Fix(VELOCITY_Y); -NODES[25].Fix(VELOCITY_Z); -NODES[26].Fix(VELOCITY_X); -NODES[26].Fix(VELOCITY_Y); -NODES[26].Fix(VELOCITY_Z); -NODES[27].Fix(VELOCITY_X); -NODES[27].Fix(VELOCITY_Y); -NODES[27].Fix(VELOCITY_Z); -NODES[28].Fix(VELOCITY_X); -NODES[28].Fix(VELOCITY_Y); -NODES[28].Fix(VELOCITY_Z); -NODES[29].Fix(VELOCITY_X); -NODES[29].Fix(VELOCITY_Y); -NODES[29].Fix(VELOCITY_Z); -NODES[30].Fix(VELOCITY_X); -NODES[30].Fix(VELOCITY_Y); -NODES[30].Fix(VELOCITY_Z); -NODES[31].Fix(VELOCITY_X); -NODES[31].Fix(VELOCITY_Y); -NODES[31].Fix(VELOCITY_Z); -NODES[32].Fix(VELOCITY_X); -NODES[32].Fix(VELOCITY_Y); -NODES[32].Fix(VELOCITY_Z); -NODES[33].Fix(VELOCITY_X); -NODES[33].Fix(VELOCITY_Y); -NODES[33].Fix(VELOCITY_Z); -NODES[34].Fix(VELOCITY_X); -NODES[34].Fix(VELOCITY_Y); -NODES[34].Fix(VELOCITY_Z); -NODES[35].Fix(VELOCITY_X); -NODES[35].Fix(VELOCITY_Y); -NODES[35].Fix(VELOCITY_Z); -NODES[36].Fix(VELOCITY_X); -NODES[36].Fix(VELOCITY_Y); -NODES[36].Fix(VELOCITY_Z); -NODES[37].Fix(VELOCITY_X); -NODES[37].Fix(VELOCITY_Y); -NODES[37].Fix(VELOCITY_Z); -NODES[38].Fix(VELOCITY_X); -NODES[38].Fix(VELOCITY_Y); -NODES[38].Fix(VELOCITY_Z); -NODES[39].Fix(VELOCITY_X); -NODES[39].Fix(VELOCITY_Y); -NODES[39].Fix(VELOCITY_Z); -NODES[40].Fix(VELOCITY_X); -NODES[40].Fix(VELOCITY_Y); -NODES[40].Fix(VELOCITY_Z); -NODES[41].Fix(VELOCITY_X); -NODES[41].Fix(VELOCITY_Y); -NODES[41].Fix(VELOCITY_Z); -NODES[42].Fix(VELOCITY_X); -NODES[42].Fix(VELOCITY_Y); -NODES[42].Fix(VELOCITY_Z); -NODES[43].Fix(VELOCITY_X); -NODES[43].Fix(VELOCITY_Y); -NODES[43].Fix(VELOCITY_Z); -NODES[44].Fix(VELOCITY_X); -NODES[44].Fix(VELOCITY_Y); -NODES[44].Fix(VELOCITY_Z); -NODES[45].Fix(VELOCITY_X); -NODES[45].Fix(VELOCITY_Y); -NODES[45].Fix(VELOCITY_Z); -NODES[46].Fix(VELOCITY_X); -NODES[46].Fix(VELOCITY_Y); -NODES[46].Fix(VELOCITY_Z); -NODES[47].Fix(VELOCITY_X); -NODES[47].Fix(VELOCITY_Y); -NODES[47].Fix(VELOCITY_Z); -NODES[48].Fix(VELOCITY_X); -NODES[48].Fix(VELOCITY_Y); -NODES[48].Fix(VELOCITY_Z); -NODES[49].Fix(VELOCITY_X); -NODES[49].Fix(VELOCITY_Y); -NODES[49].Fix(VELOCITY_Z); -NODES[50].Fix(VELOCITY_X); -NODES[50].Fix(VELOCITY_Y); -NODES[50].Fix(VELOCITY_Z); -NODES[51].Fix(VELOCITY_X); -NODES[51].Fix(VELOCITY_Y); -NODES[51].Fix(VELOCITY_Z); -NODES[52].Fix(VELOCITY_X); -NODES[52].Fix(VELOCITY_Y); -NODES[52].Fix(VELOCITY_Z); -NODES[53].Fix(VELOCITY_X); -NODES[53].Fix(VELOCITY_Y); -NODES[53].Fix(VELOCITY_Z); -NODES[54].Fix(VELOCITY_X); -NODES[54].Fix(VELOCITY_Y); -NODES[54].Fix(VELOCITY_Z); -NODES[55].Fix(VELOCITY_X); -NODES[55].Fix(VELOCITY_Y); -NODES[55].Fix(VELOCITY_Z); -NODES[56].Fix(VELOCITY_X); -NODES[56].Fix(VELOCITY_Y); -NODES[56].Fix(VELOCITY_Z); -NODES[57].Fix(VELOCITY_X); -NODES[57].Fix(VELOCITY_Y); -NODES[57].Fix(VELOCITY_Z); -NODES[58].Fix(VELOCITY_X); -NODES[58].Fix(VELOCITY_Y); -NODES[58].Fix(VELOCITY_Z); -NODES[59].Fix(VELOCITY_X); -NODES[59].Fix(VELOCITY_Y); -NODES[59].Fix(VELOCITY_Z); -NODES[60].Fix(VELOCITY_X); -NODES[60].Fix(VELOCITY_Y); -NODES[60].Fix(VELOCITY_Z); -NODES[61].Fix(VELOCITY_X); -NODES[61].Fix(VELOCITY_Y); -NODES[61].Fix(VELOCITY_Z); -NODES[62].Fix(VELOCITY_X); -NODES[62].Fix(VELOCITY_Y); -NODES[62].Fix(VELOCITY_Z); -NODES[63].Fix(VELOCITY_X); -NODES[63].Fix(VELOCITY_Y); -NODES[63].Fix(VELOCITY_Z); -NODES[64].Fix(VELOCITY_X); -NODES[64].Fix(VELOCITY_Y); -NODES[64].Fix(VELOCITY_Z); -NODES[65].Fix(VELOCITY_X); -NODES[65].Fix(VELOCITY_Y); -NODES[65].Fix(VELOCITY_Z); -NODES[66].Fix(VELOCITY_X); -NODES[66].Fix(VELOCITY_Y); -NODES[66].Fix(VELOCITY_Z); -NODES[67].Fix(VELOCITY_X); -NODES[67].Fix(VELOCITY_Y); -NODES[67].Fix(VELOCITY_Z); -NODES[68].Fix(VELOCITY_X); -NODES[68].Fix(VELOCITY_Y); -NODES[68].Fix(VELOCITY_Z); -NODES[69].Fix(VELOCITY_X); -NODES[69].Fix(VELOCITY_Y); -NODES[69].Fix(VELOCITY_Z); -NODES[70].Fix(VELOCITY_X); -NODES[70].Fix(VELOCITY_Y); -NODES[70].Fix(VELOCITY_Z); -NODES[71].Fix(VELOCITY_X); -NODES[71].Fix(VELOCITY_Y); -NODES[71].Fix(VELOCITY_Z); -NODES[72].Fix(VELOCITY_X); -NODES[72].Fix(VELOCITY_Y); -NODES[72].Fix(VELOCITY_Z); -NODES[73].Fix(VELOCITY_X); -NODES[73].Fix(VELOCITY_Y); -NODES[73].Fix(VELOCITY_Z); -NODES[74].Fix(VELOCITY_X); -NODES[74].Fix(VELOCITY_Y); -NODES[74].Fix(VELOCITY_Z); -NODES[75].Fix(VELOCITY_X); -NODES[75].Fix(VELOCITY_Y); -NODES[75].Fix(VELOCITY_Z); -NODES[76].Fix(VELOCITY_X); -NODES[76].Fix(VELOCITY_Y); -NODES[76].Fix(VELOCITY_Z); -NODES[77].Fix(VELOCITY_X); -NODES[77].Fix(VELOCITY_Y); -NODES[77].Fix(VELOCITY_Z); -NODES[78].Fix(VELOCITY_X); -NODES[78].Fix(VELOCITY_Y); -NODES[78].Fix(VELOCITY_Z); -NODES[79].Fix(VELOCITY_X); -NODES[79].Fix(VELOCITY_Y); -NODES[79].Fix(VELOCITY_Z); -NODES[80].Fix(VELOCITY_X); -NODES[80].Fix(VELOCITY_Y); -NODES[80].Fix(VELOCITY_Z); -NODES[81].Fix(VELOCITY_X); -NODES[81].Fix(VELOCITY_Y); -NODES[81].Fix(VELOCITY_Z); -NODES[82].Fix(VELOCITY_X); -NODES[82].Fix(VELOCITY_Y); -NODES[82].Fix(VELOCITY_Z); -NODES[83].Fix(VELOCITY_X); -NODES[83].Fix(VELOCITY_Y); -NODES[83].Fix(VELOCITY_Z); -NODES[84].Fix(VELOCITY_X); -NODES[84].Fix(VELOCITY_Y); -NODES[84].Fix(VELOCITY_Z); -NODES[85].Fix(VELOCITY_X); -NODES[85].Fix(VELOCITY_Y); -NODES[85].Fix(VELOCITY_Z); -NODES[86].Fix(VELOCITY_X); -NODES[86].Fix(VELOCITY_Y); -NODES[86].Fix(VELOCITY_Z); -NODES[87].Fix(VELOCITY_X); -NODES[87].Fix(VELOCITY_Y); -NODES[87].Fix(VELOCITY_Z); -NODES[88].Fix(VELOCITY_X); -NODES[88].Fix(VELOCITY_Y); -NODES[88].Fix(VELOCITY_Z); -NODES[89].Fix(VELOCITY_X); -NODES[89].Fix(VELOCITY_Y); -NODES[89].Fix(VELOCITY_Z); -NODES[90].Fix(VELOCITY_X); -NODES[90].Fix(VELOCITY_Y); -NODES[90].Fix(VELOCITY_Z); -NODES[91].Fix(VELOCITY_X); -NODES[91].Fix(VELOCITY_Y); -NODES[91].Fix(VELOCITY_Z); -NODES[92].Fix(VELOCITY_X); -NODES[92].Fix(VELOCITY_Y); -NODES[92].Fix(VELOCITY_Z); -NODES[93].Fix(VELOCITY_X); -NODES[93].Fix(VELOCITY_Y); -NODES[93].Fix(VELOCITY_Z); -NODES[94].Fix(VELOCITY_X); -NODES[94].Fix(VELOCITY_Y); -NODES[94].Fix(VELOCITY_Z); -NODES[95].Fix(VELOCITY_X); -NODES[95].Fix(VELOCITY_Y); -NODES[95].Fix(VELOCITY_Z); -NODES[96].Fix(VELOCITY_X); -NODES[96].Fix(VELOCITY_Y); -NODES[96].Fix(VELOCITY_Z); -NODES[97].Fix(VELOCITY_X); -NODES[97].Fix(VELOCITY_Y); -NODES[97].Fix(VELOCITY_Z); -NODES[98].Fix(VELOCITY_X); -NODES[98].Fix(VELOCITY_Y); -NODES[98].Fix(VELOCITY_Z); -NODES[99].Fix(VELOCITY_X); -NODES[99].Fix(VELOCITY_Y); -NODES[99].Fix(VELOCITY_Z); -NODES[100].Fix(VELOCITY_X); -NODES[100].Fix(VELOCITY_Y); -NODES[100].Fix(VELOCITY_Z); -NODES[101].Fix(VELOCITY_X); -NODES[101].Fix(VELOCITY_Y); -NODES[101].Fix(VELOCITY_Z); -NODES[102].Fix(VELOCITY_X); -NODES[102].Fix(VELOCITY_Y); -NODES[102].Fix(VELOCITY_Z); -NODES[103].Fix(VELOCITY_X); -NODES[103].Fix(VELOCITY_Y); -NODES[103].Fix(VELOCITY_Z); -NODES[104].Fix(VELOCITY_X); -NODES[104].Fix(VELOCITY_Y); -NODES[104].Fix(VELOCITY_Z); -NODES[105].Fix(VELOCITY_X); -NODES[105].Fix(VELOCITY_Y); -NODES[105].Fix(VELOCITY_Z); -NODES[106].Fix(VELOCITY_X); -NODES[106].Fix(VELOCITY_Y); -NODES[106].Fix(VELOCITY_Z); -NODES[107].Fix(VELOCITY_X); -NODES[107].Fix(VELOCITY_Y); -NODES[107].Fix(VELOCITY_Z); -NODES[108].Fix(VELOCITY_X); -NODES[108].Fix(VELOCITY_Y); -NODES[108].Fix(VELOCITY_Z); -NODES[109].Fix(VELOCITY_X); -NODES[109].Fix(VELOCITY_Y); -NODES[109].Fix(VELOCITY_Z); -NODES[110].Fix(VELOCITY_X); -NODES[110].Fix(VELOCITY_Y); -NODES[110].Fix(VELOCITY_Z); -NODES[111].Fix(VELOCITY_X); -NODES[111].Fix(VELOCITY_Y); -NODES[111].Fix(VELOCITY_Z); -NODES[112].Fix(VELOCITY_X); -NODES[112].Fix(VELOCITY_Y); -NODES[112].Fix(VELOCITY_Z); -NODES[113].Fix(VELOCITY_X); -NODES[113].Fix(VELOCITY_Y); -NODES[113].Fix(VELOCITY_Z); -NODES[114].Fix(VELOCITY_X); -NODES[114].Fix(VELOCITY_Y); -NODES[114].Fix(VELOCITY_Z); -NODES[115].Fix(VELOCITY_X); -NODES[115].Fix(VELOCITY_Y); -NODES[115].Fix(VELOCITY_Z); -NODES[116].Fix(VELOCITY_X); -NODES[116].Fix(VELOCITY_Y); -NODES[116].Fix(VELOCITY_Z); -NODES[117].Fix(VELOCITY_X); -NODES[117].Fix(VELOCITY_Y); -NODES[117].Fix(VELOCITY_Z); -NODES[118].Fix(VELOCITY_X); -NODES[118].Fix(VELOCITY_Y); -NODES[118].Fix(VELOCITY_Z); -NODES[119].Fix(VELOCITY_X); -NODES[119].Fix(VELOCITY_Y); -NODES[119].Fix(VELOCITY_Z); -NODES[120].Fix(VELOCITY_X); -NODES[120].Fix(VELOCITY_Y); -NODES[120].Fix(VELOCITY_Z); -NODES[121].Fix(VELOCITY_X); -NODES[121].Fix(VELOCITY_Y); -NODES[121].Fix(VELOCITY_Z); -NODES[122].Fix(VELOCITY_X); -NODES[122].Fix(VELOCITY_Y); -NODES[122].Fix(VELOCITY_Z); -NODES[123].Fix(VELOCITY_X); -NODES[123].Fix(VELOCITY_Y); -NODES[123].Fix(VELOCITY_Z); -NODES[124].Fix(VELOCITY_X); -NODES[124].Fix(VELOCITY_Y); -NODES[124].Fix(VELOCITY_Z); -NODES[125].Fix(VELOCITY_X); -NODES[125].Fix(VELOCITY_Y); -NODES[125].Fix(VELOCITY_Z); -NODES[126].Fix(VELOCITY_X); -NODES[126].Fix(VELOCITY_Y); -NODES[126].Fix(VELOCITY_Z); -NODES[127].Fix(VELOCITY_X); -NODES[127].Fix(VELOCITY_Y); -NODES[127].Fix(VELOCITY_Z); -NODES[128].Fix(VELOCITY_X); -NODES[128].Fix(VELOCITY_Y); -NODES[128].Fix(VELOCITY_Z); -NODES[129].Fix(VELOCITY_X); -NODES[129].Fix(VELOCITY_Y); -NODES[129].Fix(VELOCITY_Z); -NODES[130].Fix(VELOCITY_X); -NODES[130].Fix(VELOCITY_Y); -NODES[130].Fix(VELOCITY_Z); -NODES[131].Fix(VELOCITY_X); -NODES[131].Fix(VELOCITY_Y); -NODES[131].Fix(VELOCITY_Z); -NODES[132].Fix(VELOCITY_X); -NODES[132].Fix(VELOCITY_Y); -NODES[132].Fix(VELOCITY_Z); -NODES[133].Fix(VELOCITY_X); -NODES[133].Fix(VELOCITY_Y); -NODES[133].Fix(VELOCITY_Z); -NODES[134].Fix(VELOCITY_X); -NODES[134].Fix(VELOCITY_Y); -NODES[134].Fix(VELOCITY_Z); -NODES[135].Fix(VELOCITY_X); -NODES[135].Fix(VELOCITY_Y); -NODES[135].Fix(VELOCITY_Z); -NODES[136].Fix(VELOCITY_X); -NODES[136].Fix(VELOCITY_Y); -NODES[136].Fix(VELOCITY_Z); -NODES[137].Fix(VELOCITY_X); -NODES[137].Fix(VELOCITY_Y); -NODES[137].Fix(VELOCITY_Z); -NODES[138].Fix(VELOCITY_X); -NODES[138].Fix(VELOCITY_Y); -NODES[138].Fix(VELOCITY_Z); -NODES[139].Fix(VELOCITY_X); -NODES[139].Fix(VELOCITY_Y); -NODES[139].Fix(VELOCITY_Z); -NODES[140].Fix(VELOCITY_X); -NODES[140].Fix(VELOCITY_Y); -NODES[140].Fix(VELOCITY_Z); -NODES[141].Fix(VELOCITY_X); -NODES[141].Fix(VELOCITY_Y); -NODES[141].Fix(VELOCITY_Z); -NODES[142].Fix(VELOCITY_X); -NODES[142].Fix(VELOCITY_Y); -NODES[142].Fix(VELOCITY_Z); -NODES[143].Fix(VELOCITY_X); -NODES[143].Fix(VELOCITY_Y); -NODES[143].Fix(VELOCITY_Z); -NODES[144].Fix(VELOCITY_X); -NODES[144].Fix(VELOCITY_Y); -NODES[144].Fix(VELOCITY_Z); -NODES[145].Fix(VELOCITY_X); -NODES[145].Fix(VELOCITY_Y); -NODES[145].Fix(VELOCITY_Z); -NODES[146].Fix(VELOCITY_X); -NODES[146].Fix(VELOCITY_Y); -NODES[146].Fix(VELOCITY_Z); -NODES[147].Fix(VELOCITY_X); -NODES[147].Fix(VELOCITY_Y); -NODES[147].Fix(VELOCITY_Z); -NODES[148].Fix(VELOCITY_X); -NODES[148].Fix(VELOCITY_Y); -NODES[148].Fix(VELOCITY_Z); -NODES[149].Fix(VELOCITY_X); -NODES[149].Fix(VELOCITY_Y); -NODES[149].Fix(VELOCITY_Z); -NODES[150].Fix(VELOCITY_X); -NODES[150].Fix(VELOCITY_Y); -NODES[150].Fix(VELOCITY_Z); -NODES[151].Fix(VELOCITY_X); -NODES[151].Fix(VELOCITY_Y); -NODES[151].Fix(VELOCITY_Z); -NODES[152].Fix(VELOCITY_X); -NODES[152].Fix(VELOCITY_Y); -NODES[152].Fix(VELOCITY_Z); -NODES[153].Fix(VELOCITY_X); -NODES[153].Fix(VELOCITY_Y); -NODES[153].Fix(VELOCITY_Z); -NODES[154].Fix(VELOCITY_X); -NODES[154].Fix(VELOCITY_Y); -NODES[154].Fix(VELOCITY_Z); -NODES[155].Fix(VELOCITY_X); -NODES[155].Fix(VELOCITY_Y); -NODES[155].Fix(VELOCITY_Z); -NODES[156].Fix(VELOCITY_X); -NODES[156].Fix(VELOCITY_Y); -NODES[156].Fix(VELOCITY_Z); -NODES[157].Fix(VELOCITY_X); -NODES[157].Fix(VELOCITY_Y); -NODES[157].Fix(VELOCITY_Z); -NODES[158].Fix(VELOCITY_X); -NODES[158].Fix(VELOCITY_Y); -NODES[158].Fix(VELOCITY_Z); -NODES[159].Fix(VELOCITY_X); -NODES[159].Fix(VELOCITY_Y); -NODES[159].Fix(VELOCITY_Z); -NODES[160].Fix(VELOCITY_X); -NODES[160].Fix(VELOCITY_Y); -NODES[160].Fix(VELOCITY_Z); -NODES[161].Fix(VELOCITY_X); -NODES[161].Fix(VELOCITY_Y); -NODES[161].Fix(VELOCITY_Z); -NODES[162].Fix(VELOCITY_X); -NODES[162].Fix(VELOCITY_Y); -NODES[162].Fix(VELOCITY_Z); -NODES[163].Fix(VELOCITY_X); -NODES[163].Fix(VELOCITY_Y); -NODES[163].Fix(VELOCITY_Z); -NODES[164].Fix(VELOCITY_X); -NODES[164].Fix(VELOCITY_Y); -NODES[164].Fix(VELOCITY_Z); -NODES[165].Fix(VELOCITY_X); -NODES[165].Fix(VELOCITY_Y); -NODES[165].Fix(VELOCITY_Z); -NODES[166].Fix(VELOCITY_X); -NODES[166].Fix(VELOCITY_Y); -NODES[166].Fix(VELOCITY_Z); -NODES[167].Fix(VELOCITY_X); -NODES[167].Fix(VELOCITY_Y); -NODES[167].Fix(VELOCITY_Z); -NODES[181].Fix(VELOCITY_X); -NODES[181].Fix(VELOCITY_Y); -NODES[181].Fix(VELOCITY_Z); -NODES[183].Fix(VELOCITY_X); -NODES[183].Fix(VELOCITY_Y); -NODES[183].Fix(VELOCITY_Z); -NODES[202].Fix(VELOCITY_X); -NODES[202].Fix(VELOCITY_Y); -NODES[202].Fix(VELOCITY_Z); -NODES[204].Fix(VELOCITY_X); -NODES[204].Fix(VELOCITY_Y); -NODES[204].Fix(VELOCITY_Z); -NODES[228].Fix(VELOCITY_X); -NODES[228].Fix(VELOCITY_Y); -NODES[228].Fix(VELOCITY_Z); -NODES[231].Fix(VELOCITY_X); -NODES[231].Fix(VELOCITY_Y); -NODES[231].Fix(VELOCITY_Z); -NODES[257].Fix(VELOCITY_X); -NODES[257].Fix(VELOCITY_Y); -NODES[257].Fix(VELOCITY_Z); -NODES[261].Fix(VELOCITY_X); -NODES[261].Fix(VELOCITY_Y); -NODES[261].Fix(VELOCITY_Z); -NODES[291].Fix(VELOCITY_X); -NODES[291].Fix(VELOCITY_Y); -NODES[291].Fix(VELOCITY_Z); -NODES[299].Fix(VELOCITY_X); -NODES[299].Fix(VELOCITY_Y); -NODES[299].Fix(VELOCITY_Z); -NODES[329].Fix(VELOCITY_X); -NODES[329].Fix(VELOCITY_Y); -NODES[329].Fix(VELOCITY_Z); -NODES[337].Fix(VELOCITY_X); -NODES[337].Fix(VELOCITY_Y); -NODES[337].Fix(VELOCITY_Z); -NODES[371].Fix(VELOCITY_X); -NODES[371].Fix(VELOCITY_Y); -NODES[371].Fix(VELOCITY_Z); -NODES[381].Fix(VELOCITY_X); -NODES[381].Fix(VELOCITY_Y); -NODES[381].Fix(VELOCITY_Z); -NODES[414].Fix(VELOCITY_X); -NODES[414].Fix(VELOCITY_Y); -NODES[414].Fix(VELOCITY_Z); -NODES[425].Fix(VELOCITY_X); -NODES[425].Fix(VELOCITY_Y); -NODES[425].Fix(VELOCITY_Z); -NODES[462].Fix(VELOCITY_X); -NODES[462].Fix(VELOCITY_Y); -NODES[462].Fix(VELOCITY_Z); -NODES[470].Fix(VELOCITY_X); -NODES[470].Fix(VELOCITY_Y); -NODES[470].Fix(VELOCITY_Z); -NODES[505].Fix(VELOCITY_X); -NODES[505].Fix(VELOCITY_Y); -NODES[505].Fix(VELOCITY_Z); -NODES[518].Fix(VELOCITY_X); -NODES[518].Fix(VELOCITY_Y); -NODES[518].Fix(VELOCITY_Z); -NODES[557].Fix(VELOCITY_X); -NODES[557].Fix(VELOCITY_Y); -NODES[557].Fix(VELOCITY_Z); -NODES[570].Fix(VELOCITY_X); -NODES[570].Fix(VELOCITY_Y); -NODES[570].Fix(VELOCITY_Z); -NODES[607].Fix(VELOCITY_X); -NODES[607].Fix(VELOCITY_Y); -NODES[607].Fix(VELOCITY_Z); -NODES[622].Fix(VELOCITY_X); -NODES[622].Fix(VELOCITY_Y); -NODES[622].Fix(VELOCITY_Z); -NODES[663].Fix(VELOCITY_X); -NODES[663].Fix(VELOCITY_Y); -NODES[663].Fix(VELOCITY_Z); -NODES[677].Fix(VELOCITY_X); -NODES[677].Fix(VELOCITY_Y); -NODES[677].Fix(VELOCITY_Z); -NODES[721].Fix(VELOCITY_X); -NODES[721].Fix(VELOCITY_Y); -NODES[721].Fix(VELOCITY_Z); -NODES[738].Fix(VELOCITY_X); -NODES[738].Fix(VELOCITY_Y); -NODES[738].Fix(VELOCITY_Z); -NODES[781].Fix(VELOCITY_X); -NODES[781].Fix(VELOCITY_Y); -NODES[781].Fix(VELOCITY_Z); -NODES[802].Fix(VELOCITY_X); -NODES[802].Fix(VELOCITY_Y); -NODES[802].Fix(VELOCITY_Z); -NODES[845].Fix(VELOCITY_X); -NODES[845].Fix(VELOCITY_Y); -NODES[845].Fix(VELOCITY_Z); -NODES[867].Fix(VELOCITY_X); -NODES[867].Fix(VELOCITY_Y); -NODES[867].Fix(VELOCITY_Z); -NODES[912].Fix(VELOCITY_X); -NODES[912].Fix(VELOCITY_Y); -NODES[912].Fix(VELOCITY_Z); -NODES[938].Fix(VELOCITY_X); -NODES[938].Fix(VELOCITY_Y); -NODES[938].Fix(VELOCITY_Z); -NODES[983].Fix(VELOCITY_X); -NODES[983].Fix(VELOCITY_Y); -NODES[983].Fix(VELOCITY_Z); -NODES[1009].Fix(VELOCITY_X); -NODES[1009].Fix(VELOCITY_Y); -NODES[1009].Fix(VELOCITY_Z); -NODES[1048].Fix(VELOCITY_X); -NODES[1048].Fix(VELOCITY_Y); -NODES[1048].Fix(VELOCITY_Z); -NODES[1049].Fix(VELOCITY_X); -NODES[1049].Fix(VELOCITY_Y); -NODES[1049].Fix(VELOCITY_Z); -NODES[1051].Fix(VELOCITY_X); -NODES[1051].Fix(VELOCITY_Y); -NODES[1051].Fix(VELOCITY_Z); -NODES[1054].Fix(VELOCITY_X); -NODES[1054].Fix(VELOCITY_Y); -NODES[1054].Fix(VELOCITY_Z); -NODES[1057].Fix(VELOCITY_X); -NODES[1057].Fix(VELOCITY_Y); -NODES[1057].Fix(VELOCITY_Z); -NODES[1061].Fix(VELOCITY_X); -NODES[1061].Fix(VELOCITY_Y); -NODES[1061].Fix(VELOCITY_Z); -NODES[1062].Fix(VELOCITY_X); -NODES[1062].Fix(VELOCITY_Y); -NODES[1062].Fix(VELOCITY_Z); -NODES[1068].Fix(VELOCITY_X); -NODES[1068].Fix(VELOCITY_Y); -NODES[1068].Fix(VELOCITY_Z); -NODES[1070].Fix(VELOCITY_X); -NODES[1070].Fix(VELOCITY_Y); -NODES[1070].Fix(VELOCITY_Z); -NODES[1079].Fix(VELOCITY_X); -NODES[1079].Fix(VELOCITY_Y); -NODES[1079].Fix(VELOCITY_Z); -NODES[1080].Fix(VELOCITY_X); -NODES[1080].Fix(VELOCITY_Y); -NODES[1080].Fix(VELOCITY_Z); -NODES[1086].Fix(VELOCITY_X); -NODES[1086].Fix(VELOCITY_Y); -NODES[1086].Fix(VELOCITY_Z); -NODES[1095].Fix(VELOCITY_X); -NODES[1095].Fix(VELOCITY_Y); -NODES[1095].Fix(VELOCITY_Z); -NODES[1101].Fix(VELOCITY_X); -NODES[1101].Fix(VELOCITY_Y); -NODES[1101].Fix(VELOCITY_Z); -NODES[1105].Fix(VELOCITY_X); -NODES[1105].Fix(VELOCITY_Y); -NODES[1105].Fix(VELOCITY_Z); -NODES[1115].Fix(VELOCITY_X); -NODES[1115].Fix(VELOCITY_Y); -NODES[1115].Fix(VELOCITY_Z); -NODES[1126].Fix(VELOCITY_X); -NODES[1126].Fix(VELOCITY_Y); -NODES[1126].Fix(VELOCITY_Z); -NODES[1132].Fix(VELOCITY_X); -NODES[1132].Fix(VELOCITY_Y); -NODES[1132].Fix(VELOCITY_Z); -NODES[1140].Fix(VELOCITY_X); -NODES[1140].Fix(VELOCITY_Y); -NODES[1140].Fix(VELOCITY_Z); -NODES[1143].Fix(VELOCITY_X); -NODES[1143].Fix(VELOCITY_Y); -NODES[1143].Fix(VELOCITY_Z); -NODES[1152].Fix(VELOCITY_X); -NODES[1152].Fix(VELOCITY_Y); -NODES[1152].Fix(VELOCITY_Z); -NODES[1162].Fix(VELOCITY_X); -NODES[1162].Fix(VELOCITY_Y); -NODES[1162].Fix(VELOCITY_Z); -NODES[1173].Fix(VELOCITY_X); -NODES[1173].Fix(VELOCITY_Y); -NODES[1173].Fix(VELOCITY_Z); -NODES[1184].Fix(VELOCITY_X); -NODES[1184].Fix(VELOCITY_Y); -NODES[1184].Fix(VELOCITY_Z); -NODES[1194].Fix(VELOCITY_X); -NODES[1194].Fix(VELOCITY_Y); -NODES[1194].Fix(VELOCITY_Z); -NODES[1200].Fix(VELOCITY_X); -NODES[1200].Fix(VELOCITY_Y); -NODES[1200].Fix(VELOCITY_Z); -NODES[1207].Fix(VELOCITY_X); -NODES[1207].Fix(VELOCITY_Y); -NODES[1207].Fix(VELOCITY_Z); -NODES[1218].Fix(VELOCITY_X); -NODES[1218].Fix(VELOCITY_Y); -NODES[1218].Fix(VELOCITY_Z); -NODES[1233].Fix(VELOCITY_X); -NODES[1233].Fix(VELOCITY_Y); -NODES[1233].Fix(VELOCITY_Z); -NODES[1244].Fix(VELOCITY_X); -NODES[1244].Fix(VELOCITY_Y); -NODES[1244].Fix(VELOCITY_Z); -NODES[1252].Fix(VELOCITY_X); -NODES[1252].Fix(VELOCITY_Y); -NODES[1252].Fix(VELOCITY_Z); -NODES[1258].Fix(VELOCITY_X); -NODES[1258].Fix(VELOCITY_Y); -NODES[1258].Fix(VELOCITY_Z); -NODES[1269].Fix(VELOCITY_X); -NODES[1269].Fix(VELOCITY_Y); -NODES[1269].Fix(VELOCITY_Z); -NODES[1287].Fix(VELOCITY_X); -NODES[1287].Fix(VELOCITY_Y); -NODES[1287].Fix(VELOCITY_Z); -NODES[1296].Fix(VELOCITY_X); -NODES[1296].Fix(VELOCITY_Y); -NODES[1296].Fix(VELOCITY_Z); -NODES[1301].Fix(VELOCITY_X); -NODES[1301].Fix(VELOCITY_Y); -NODES[1301].Fix(VELOCITY_Z); -NODES[1314].Fix(VELOCITY_X); -NODES[1314].Fix(VELOCITY_Y); -NODES[1314].Fix(VELOCITY_Z); -NODES[1327].Fix(VELOCITY_X); -NODES[1327].Fix(VELOCITY_Y); -NODES[1327].Fix(VELOCITY_Z); -NODES[1342].Fix(VELOCITY_X); -NODES[1342].Fix(VELOCITY_Y); -NODES[1342].Fix(VELOCITY_Z); -NODES[1349].Fix(VELOCITY_X); -NODES[1349].Fix(VELOCITY_Y); -NODES[1349].Fix(VELOCITY_Z); -NODES[1356].Fix(VELOCITY_X); -NODES[1356].Fix(VELOCITY_Y); -NODES[1356].Fix(VELOCITY_Z); -NODES[1370].Fix(VELOCITY_X); -NODES[1370].Fix(VELOCITY_Y); -NODES[1370].Fix(VELOCITY_Z); -NODES[1386].Fix(VELOCITY_X); -NODES[1386].Fix(VELOCITY_Y); -NODES[1386].Fix(VELOCITY_Z); -NODES[1396].Fix(VELOCITY_X); -NODES[1396].Fix(VELOCITY_Y); -NODES[1396].Fix(VELOCITY_Z); -NODES[1403].Fix(VELOCITY_X); -NODES[1403].Fix(VELOCITY_Y); -NODES[1403].Fix(VELOCITY_Z); -NODES[1416].Fix(VELOCITY_X); -NODES[1416].Fix(VELOCITY_Y); -NODES[1416].Fix(VELOCITY_Z); -NODES[1434].Fix(VELOCITY_X); -NODES[1434].Fix(VELOCITY_Y); -NODES[1434].Fix(VELOCITY_Z); -NODES[1441].Fix(VELOCITY_X); -NODES[1441].Fix(VELOCITY_Y); -NODES[1441].Fix(VELOCITY_Z); -NODES[1452].Fix(VELOCITY_X); -NODES[1452].Fix(VELOCITY_Y); -NODES[1452].Fix(VELOCITY_Z); -NODES[1467].Fix(VELOCITY_X); -NODES[1467].Fix(VELOCITY_Y); -NODES[1467].Fix(VELOCITY_Z); -NODES[1480].Fix(VELOCITY_X); -NODES[1480].Fix(VELOCITY_Y); -NODES[1480].Fix(VELOCITY_Z); -NODES[1485].Fix(VELOCITY_X); -NODES[1485].Fix(VELOCITY_Y); -NODES[1485].Fix(VELOCITY_Z); -NODES[1500].Fix(VELOCITY_X); -NODES[1500].Fix(VELOCITY_Y); -NODES[1500].Fix(VELOCITY_Z); -NODES[1517].Fix(VELOCITY_X); -NODES[1517].Fix(VELOCITY_Y); -NODES[1517].Fix(VELOCITY_Z); -NODES[1527].Fix(VELOCITY_X); -NODES[1527].Fix(VELOCITY_Y); -NODES[1527].Fix(VELOCITY_Z); -NODES[1534].Fix(VELOCITY_X); -NODES[1534].Fix(VELOCITY_Y); -NODES[1534].Fix(VELOCITY_Z); -NODES[1550].Fix(VELOCITY_X); -NODES[1550].Fix(VELOCITY_Y); -NODES[1550].Fix(VELOCITY_Z); -NODES[1566].Fix(VELOCITY_X); -NODES[1566].Fix(VELOCITY_Y); -NODES[1566].Fix(VELOCITY_Z); -NODES[1571].Fix(VELOCITY_X); -NODES[1571].Fix(VELOCITY_Y); -NODES[1571].Fix(VELOCITY_Z); -NODES[1584].Fix(VELOCITY_X); -NODES[1584].Fix(VELOCITY_Y); -NODES[1584].Fix(VELOCITY_Z); -NODES[1602].Fix(VELOCITY_X); -NODES[1602].Fix(VELOCITY_Y); -NODES[1602].Fix(VELOCITY_Z); -NODES[1611].Fix(VELOCITY_X); -NODES[1611].Fix(VELOCITY_Y); -NODES[1611].Fix(VELOCITY_Z); -NODES[1622].Fix(VELOCITY_X); -NODES[1622].Fix(VELOCITY_Y); -NODES[1622].Fix(VELOCITY_Z); -NODES[1639].Fix(VELOCITY_X); -NODES[1639].Fix(VELOCITY_Y); -NODES[1639].Fix(VELOCITY_Z); -NODES[1651].Fix(VELOCITY_X); -NODES[1651].Fix(VELOCITY_Y); -NODES[1651].Fix(VELOCITY_Z); -NODES[1656].Fix(VELOCITY_X); -NODES[1656].Fix(VELOCITY_Y); -NODES[1656].Fix(VELOCITY_Z); -NODES[1677].Fix(VELOCITY_X); -NODES[1677].Fix(VELOCITY_Y); -NODES[1677].Fix(VELOCITY_Z); -NODES[1690].Fix(VELOCITY_X); -NODES[1690].Fix(VELOCITY_Y); -NODES[1690].Fix(VELOCITY_Z); -NODES[1693].Fix(VELOCITY_X); -NODES[1693].Fix(VELOCITY_Y); -NODES[1693].Fix(VELOCITY_Z); -NODES[1712].Fix(VELOCITY_X); -NODES[1712].Fix(VELOCITY_Y); -NODES[1712].Fix(VELOCITY_Z); -NODES[1729].Fix(VELOCITY_X); -NODES[1729].Fix(VELOCITY_Y); -NODES[1729].Fix(VELOCITY_Z); -NODES[1730].Fix(VELOCITY_X); -NODES[1730].Fix(VELOCITY_Y); -NODES[1730].Fix(VELOCITY_Z); -NODES[1747].Fix(VELOCITY_X); -NODES[1747].Fix(VELOCITY_Y); -NODES[1747].Fix(VELOCITY_Z); -NODES[1765].Fix(VELOCITY_X); -NODES[1765].Fix(VELOCITY_Y); -NODES[1765].Fix(VELOCITY_Z); -NODES[1767].Fix(VELOCITY_X); -NODES[1767].Fix(VELOCITY_Y); -NODES[1767].Fix(VELOCITY_Z); -NODES[1784].Fix(VELOCITY_X); -NODES[1784].Fix(VELOCITY_Y); -NODES[1784].Fix(VELOCITY_Z); -NODES[1803].Fix(VELOCITY_X); -NODES[1803].Fix(VELOCITY_Y); -NODES[1803].Fix(VELOCITY_Z); -NODES[1804].Fix(VELOCITY_X); -NODES[1804].Fix(VELOCITY_Y); -NODES[1804].Fix(VELOCITY_Z); -NODES[1822].Fix(VELOCITY_X); -NODES[1822].Fix(VELOCITY_Y); -NODES[1822].Fix(VELOCITY_Z); -NODES[1839].Fix(VELOCITY_X); -NODES[1839].Fix(VELOCITY_Y); -NODES[1839].Fix(VELOCITY_Z); -NODES[1840].Fix(VELOCITY_X); -NODES[1840].Fix(VELOCITY_Y); -NODES[1840].Fix(VELOCITY_Z); -NODES[1857].Fix(VELOCITY_X); -NODES[1857].Fix(VELOCITY_Y); -NODES[1857].Fix(VELOCITY_Z); -NODES[1873].Fix(VELOCITY_X); -NODES[1873].Fix(VELOCITY_Y); -NODES[1873].Fix(VELOCITY_Z); -NODES[1876].Fix(VELOCITY_X); -NODES[1876].Fix(VELOCITY_Y); -NODES[1876].Fix(VELOCITY_Z); -NODES[1894].Fix(VELOCITY_X); -NODES[1894].Fix(VELOCITY_Y); -NODES[1894].Fix(VELOCITY_Z); -NODES[1909].Fix(VELOCITY_X); -NODES[1909].Fix(VELOCITY_Y); -NODES[1909].Fix(VELOCITY_Z); -NODES[1913].Fix(VELOCITY_X); -NODES[1913].Fix(VELOCITY_Y); -NODES[1913].Fix(VELOCITY_Z); -NODES[1932].Fix(VELOCITY_X); -NODES[1932].Fix(VELOCITY_Y); -NODES[1932].Fix(VELOCITY_Z); -NODES[1943].Fix(VELOCITY_X); -NODES[1943].Fix(VELOCITY_Y); -NODES[1943].Fix(VELOCITY_Z); -NODES[1950].Fix(VELOCITY_X); -NODES[1950].Fix(VELOCITY_Y); -NODES[1950].Fix(VELOCITY_Z); -NODES[1969].Fix(VELOCITY_X); -NODES[1969].Fix(VELOCITY_Y); -NODES[1969].Fix(VELOCITY_Z); -NODES[1975].Fix(VELOCITY_X); -NODES[1975].Fix(VELOCITY_Y); -NODES[1975].Fix(VELOCITY_Z); -NODES[1988].Fix(VELOCITY_X); -NODES[1988].Fix(VELOCITY_Y); -NODES[1988].Fix(VELOCITY_Z); -NODES[2008].Fix(VELOCITY_X); -NODES[2008].Fix(VELOCITY_Y); -NODES[2008].Fix(VELOCITY_Z); -NODES[2010].Fix(VELOCITY_X); -NODES[2010].Fix(VELOCITY_Y); -NODES[2010].Fix(VELOCITY_Z); -NODES[2025].Fix(VELOCITY_X); -NODES[2025].Fix(VELOCITY_Y); -NODES[2025].Fix(VELOCITY_Z); -NODES[2043].Fix(VELOCITY_X); -NODES[2043].Fix(VELOCITY_Y); -NODES[2043].Fix(VELOCITY_Z); -NODES[2045].Fix(VELOCITY_X); -NODES[2045].Fix(VELOCITY_Y); -NODES[2045].Fix(VELOCITY_Z); -NODES[2064].Fix(VELOCITY_X); -NODES[2064].Fix(VELOCITY_Y); -NODES[2064].Fix(VELOCITY_Z); -NODES[2077].Fix(VELOCITY_X); -NODES[2077].Fix(VELOCITY_Y); -NODES[2077].Fix(VELOCITY_Z); -NODES[2086].Fix(VELOCITY_X); -NODES[2086].Fix(VELOCITY_Y); -NODES[2086].Fix(VELOCITY_Z); -NODES[2102].Fix(VELOCITY_X); -NODES[2102].Fix(VELOCITY_Y); -NODES[2102].Fix(VELOCITY_Z); -NODES[2110].Fix(VELOCITY_X); -NODES[2110].Fix(VELOCITY_Y); -NODES[2110].Fix(VELOCITY_Z); -NODES[2124].Fix(VELOCITY_X); -NODES[2124].Fix(VELOCITY_Y); -NODES[2124].Fix(VELOCITY_Z); -NODES[2143].Fix(VELOCITY_X); -NODES[2143].Fix(VELOCITY_Y); -NODES[2143].Fix(VELOCITY_Z); -NODES[2144].Fix(VELOCITY_X); -NODES[2144].Fix(VELOCITY_Y); -NODES[2144].Fix(VELOCITY_Z); -NODES[2166].Fix(VELOCITY_X); -NODES[2166].Fix(VELOCITY_Y); -NODES[2166].Fix(VELOCITY_Z); -NODES[2176].Fix(VELOCITY_X); -NODES[2176].Fix(VELOCITY_Y); -NODES[2176].Fix(VELOCITY_Z); -NODES[2186].Fix(VELOCITY_X); -NODES[2186].Fix(VELOCITY_Y); -NODES[2186].Fix(VELOCITY_Z); -NODES[2205].Fix(VELOCITY_X); -NODES[2205].Fix(VELOCITY_Y); -NODES[2205].Fix(VELOCITY_Z); -NODES[2208].Fix(VELOCITY_X); -NODES[2208].Fix(VELOCITY_Y); -NODES[2208].Fix(VELOCITY_Z); -NODES[2226].Fix(VELOCITY_X); -NODES[2226].Fix(VELOCITY_Y); -NODES[2226].Fix(VELOCITY_Z); -NODES[2240].Fix(VELOCITY_X); -NODES[2240].Fix(VELOCITY_Y); -NODES[2240].Fix(VELOCITY_Z); -NODES[2246].Fix(VELOCITY_X); -NODES[2246].Fix(VELOCITY_Y); -NODES[2246].Fix(VELOCITY_Z); -NODES[2267].Fix(VELOCITY_X); -NODES[2267].Fix(VELOCITY_Y); -NODES[2267].Fix(VELOCITY_Z); -NODES[2272].Fix(VELOCITY_X); -NODES[2272].Fix(VELOCITY_Y); -NODES[2272].Fix(VELOCITY_Z); -NODES[2287].Fix(VELOCITY_X); -NODES[2287].Fix(VELOCITY_Y); -NODES[2287].Fix(VELOCITY_Z); -NODES[2303].Fix(VELOCITY_X); -NODES[2303].Fix(VELOCITY_Y); -NODES[2303].Fix(VELOCITY_Z); -NODES[2308].Fix(VELOCITY_X); -NODES[2308].Fix(VELOCITY_Y); -NODES[2308].Fix(VELOCITY_Z); -NODES[2326].Fix(VELOCITY_X); -NODES[2326].Fix(VELOCITY_Y); -NODES[2326].Fix(VELOCITY_Z); -NODES[2336].Fix(VELOCITY_X); -NODES[2336].Fix(VELOCITY_Y); -NODES[2336].Fix(VELOCITY_Z); -NODES[2349].Fix(VELOCITY_X); -NODES[2349].Fix(VELOCITY_Y); -NODES[2349].Fix(VELOCITY_Z); -NODES[2367].Fix(VELOCITY_X); -NODES[2367].Fix(VELOCITY_Y); -NODES[2367].Fix(VELOCITY_Z); -NODES[2369].Fix(VELOCITY_X); -NODES[2369].Fix(VELOCITY_Y); -NODES[2369].Fix(VELOCITY_Z); -NODES[2389].Fix(VELOCITY_X); -NODES[2389].Fix(VELOCITY_Y); -NODES[2389].Fix(VELOCITY_Z); -NODES[2397].Fix(VELOCITY_X); -NODES[2397].Fix(VELOCITY_Y); -NODES[2397].Fix(VELOCITY_Z); -NODES[2411].Fix(VELOCITY_X); -NODES[2411].Fix(VELOCITY_Y); -NODES[2411].Fix(VELOCITY_Z); -NODES[2428].Fix(VELOCITY_X); -NODES[2428].Fix(VELOCITY_Y); -NODES[2428].Fix(VELOCITY_Z); -NODES[2433].Fix(VELOCITY_X); -NODES[2433].Fix(VELOCITY_Y); -NODES[2433].Fix(VELOCITY_Z); -NODES[2451].Fix(VELOCITY_X); -NODES[2451].Fix(VELOCITY_Y); -NODES[2451].Fix(VELOCITY_Z); -NODES[2462].Fix(VELOCITY_X); -NODES[2462].Fix(VELOCITY_Y); -NODES[2462].Fix(VELOCITY_Z); -NODES[2472].Fix(VELOCITY_X); -NODES[2472].Fix(VELOCITY_Y); -NODES[2472].Fix(VELOCITY_Z); -NODES[2492].Fix(VELOCITY_X); -NODES[2492].Fix(VELOCITY_Y); -NODES[2492].Fix(VELOCITY_Z); -NODES[2494].Fix(VELOCITY_X); -NODES[2494].Fix(VELOCITY_Y); -NODES[2494].Fix(VELOCITY_Z); -NODES[2515].Fix(VELOCITY_X); -NODES[2515].Fix(VELOCITY_Y); -NODES[2515].Fix(VELOCITY_Z); -NODES[2522].Fix(VELOCITY_X); -NODES[2522].Fix(VELOCITY_Y); -NODES[2522].Fix(VELOCITY_Z); -NODES[2537].Fix(VELOCITY_X); -NODES[2537].Fix(VELOCITY_Y); -NODES[2537].Fix(VELOCITY_Z); -NODES[2551].Fix(VELOCITY_X); -NODES[2551].Fix(VELOCITY_Y); -NODES[2551].Fix(VELOCITY_Z); -NODES[2557].Fix(VELOCITY_X); -NODES[2557].Fix(VELOCITY_Y); -NODES[2557].Fix(VELOCITY_Z); -NODES[2578].Fix(VELOCITY_X); -NODES[2578].Fix(VELOCITY_Y); -NODES[2578].Fix(VELOCITY_Z); -NODES[2582].Fix(VELOCITY_X); -NODES[2582].Fix(VELOCITY_Y); -NODES[2582].Fix(VELOCITY_Z); -NODES[2598].Fix(VELOCITY_X); -NODES[2598].Fix(VELOCITY_Y); -NODES[2598].Fix(VELOCITY_Z); -NODES[2612].Fix(VELOCITY_X); -NODES[2612].Fix(VELOCITY_Y); -NODES[2612].Fix(VELOCITY_Z); -NODES[2620].Fix(VELOCITY_X); -NODES[2620].Fix(VELOCITY_Y); -NODES[2620].Fix(VELOCITY_Z); -NODES[2640].Fix(VELOCITY_X); -NODES[2640].Fix(VELOCITY_Y); -NODES[2640].Fix(VELOCITY_Z); -NODES[2642].Fix(VELOCITY_X); -NODES[2642].Fix(VELOCITY_Y); -NODES[2642].Fix(VELOCITY_Z); -NODES[2662].Fix(VELOCITY_X); -NODES[2662].Fix(VELOCITY_Y); -NODES[2662].Fix(VELOCITY_Z); -NODES[2671].Fix(VELOCITY_X); -NODES[2671].Fix(VELOCITY_Y); -NODES[2671].Fix(VELOCITY_Z); -NODES[2684].Fix(VELOCITY_X); -NODES[2684].Fix(VELOCITY_Y); -NODES[2684].Fix(VELOCITY_Z); -NODES[2702].Fix(VELOCITY_X); -NODES[2702].Fix(VELOCITY_Y); -NODES[2702].Fix(VELOCITY_Z); -NODES[2705].Fix(VELOCITY_X); -NODES[2705].Fix(VELOCITY_Y); -NODES[2705].Fix(VELOCITY_Z); -NODES[2725].Fix(VELOCITY_X); -NODES[2725].Fix(VELOCITY_Y); -NODES[2725].Fix(VELOCITY_Z); -NODES[2731].Fix(VELOCITY_X); -NODES[2731].Fix(VELOCITY_Y); -NODES[2731].Fix(VELOCITY_Z); -NODES[2746].Fix(VELOCITY_X); -NODES[2746].Fix(VELOCITY_Y); -NODES[2746].Fix(VELOCITY_Z); -NODES[2760].Fix(VELOCITY_X); -NODES[2760].Fix(VELOCITY_Y); -NODES[2760].Fix(VELOCITY_Z); -NODES[2767].Fix(VELOCITY_X); -NODES[2767].Fix(VELOCITY_Y); -NODES[2767].Fix(VELOCITY_Z); -NODES[2788].Fix(VELOCITY_X); -NODES[2788].Fix(VELOCITY_Y); -NODES[2788].Fix(VELOCITY_Z); -NODES[2789].Fix(VELOCITY_X); -NODES[2789].Fix(VELOCITY_Y); -NODES[2789].Fix(VELOCITY_Z); -NODES[2811].Fix(VELOCITY_X); -NODES[2811].Fix(VELOCITY_Y); -NODES[2811].Fix(VELOCITY_Z); -NODES[2817].Fix(VELOCITY_X); -NODES[2817].Fix(VELOCITY_Y); -NODES[2817].Fix(VELOCITY_Z); -NODES[2832].Fix(VELOCITY_X); -NODES[2832].Fix(VELOCITY_Y); -NODES[2832].Fix(VELOCITY_Z); -NODES[2848].Fix(VELOCITY_X); -NODES[2848].Fix(VELOCITY_Y); -NODES[2848].Fix(VELOCITY_Z); -NODES[2855].Fix(VELOCITY_X); -NODES[2855].Fix(VELOCITY_Y); -NODES[2855].Fix(VELOCITY_Z); -NODES[2876].Fix(VELOCITY_X); -NODES[2876].Fix(VELOCITY_Y); -NODES[2876].Fix(VELOCITY_Z); -NODES[2878].Fix(VELOCITY_X); -NODES[2878].Fix(VELOCITY_Y); -NODES[2878].Fix(VELOCITY_Z); -NODES[2896].Fix(VELOCITY_X); -NODES[2896].Fix(VELOCITY_Y); -NODES[2896].Fix(VELOCITY_Z); -NODES[2905].Fix(VELOCITY_X); -NODES[2905].Fix(VELOCITY_Y); -NODES[2905].Fix(VELOCITY_Z); -NODES[2918].Fix(VELOCITY_X); -NODES[2918].Fix(VELOCITY_Y); -NODES[2918].Fix(VELOCITY_Z); -NODES[2932].Fix(VELOCITY_X); -NODES[2932].Fix(VELOCITY_Y); -NODES[2932].Fix(VELOCITY_Z); -NODES[2939].Fix(VELOCITY_X); -NODES[2939].Fix(VELOCITY_Y); -NODES[2939].Fix(VELOCITY_Z); -NODES[2959].Fix(VELOCITY_X); -NODES[2959].Fix(VELOCITY_Y); -NODES[2959].Fix(VELOCITY_Z); -NODES[2962].Fix(VELOCITY_X); -NODES[2962].Fix(VELOCITY_Y); -NODES[2962].Fix(VELOCITY_Z); -NODES[2981].Fix(VELOCITY_X); -NODES[2981].Fix(VELOCITY_Y); -NODES[2981].Fix(VELOCITY_Z); -NODES[2991].Fix(VELOCITY_X); -NODES[2991].Fix(VELOCITY_Y); -NODES[2991].Fix(VELOCITY_Z); -NODES[3004].Fix(VELOCITY_X); -NODES[3004].Fix(VELOCITY_Y); -NODES[3004].Fix(VELOCITY_Z); -NODES[3020].Fix(VELOCITY_X); -NODES[3020].Fix(VELOCITY_Y); -NODES[3020].Fix(VELOCITY_Z); -NODES[3026].Fix(VELOCITY_X); -NODES[3026].Fix(VELOCITY_Y); -NODES[3026].Fix(VELOCITY_Z); -NODES[3048].Fix(VELOCITY_X); -NODES[3048].Fix(VELOCITY_Y); -NODES[3048].Fix(VELOCITY_Z); -NODES[3049].Fix(VELOCITY_X); -NODES[3049].Fix(VELOCITY_Y); -NODES[3049].Fix(VELOCITY_Z); -NODES[3069].Fix(VELOCITY_X); -NODES[3069].Fix(VELOCITY_Y); -NODES[3069].Fix(VELOCITY_Z); -NODES[3075].Fix(VELOCITY_X); -NODES[3075].Fix(VELOCITY_Y); -NODES[3075].Fix(VELOCITY_Z); -NODES[3091].Fix(VELOCITY_X); -NODES[3091].Fix(VELOCITY_Y); -NODES[3091].Fix(VELOCITY_Z); -NODES[3102].Fix(VELOCITY_X); -NODES[3102].Fix(VELOCITY_Y); -NODES[3102].Fix(VELOCITY_Z); -NODES[3114].Fix(VELOCITY_X); -NODES[3114].Fix(VELOCITY_Y); -NODES[3114].Fix(VELOCITY_Z); -NODES[3131].Fix(VELOCITY_X); -NODES[3131].Fix(VELOCITY_Y); -NODES[3131].Fix(VELOCITY_Z); -NODES[3136].Fix(VELOCITY_X); -NODES[3136].Fix(VELOCITY_Y); -NODES[3136].Fix(VELOCITY_Z); -NODES[3156].Fix(VELOCITY_X); -NODES[3156].Fix(VELOCITY_Y); -NODES[3156].Fix(VELOCITY_Z); -NODES[3161].Fix(VELOCITY_X); -NODES[3161].Fix(VELOCITY_Y); -NODES[3161].Fix(VELOCITY_Z); -NODES[3174].Fix(VELOCITY_X); -NODES[3174].Fix(VELOCITY_Y); -NODES[3174].Fix(VELOCITY_Z); -NODES[3188].Fix(VELOCITY_X); -NODES[3188].Fix(VELOCITY_Y); -NODES[3188].Fix(VELOCITY_Z); -NODES[3196].Fix(VELOCITY_X); -NODES[3196].Fix(VELOCITY_Y); -NODES[3196].Fix(VELOCITY_Z); -NODES[3215].Fix(VELOCITY_X); -NODES[3215].Fix(VELOCITY_Y); -NODES[3215].Fix(VELOCITY_Z); -NODES[3219].Fix(VELOCITY_X); -NODES[3219].Fix(VELOCITY_Y); -NODES[3219].Fix(VELOCITY_Z); -NODES[3241].Fix(VELOCITY_X); -NODES[3241].Fix(VELOCITY_Y); -NODES[3241].Fix(VELOCITY_Z); -NODES[3242].Fix(VELOCITY_X); -NODES[3242].Fix(VELOCITY_Y); -NODES[3242].Fix(VELOCITY_Z); -NODES[3263].Fix(VELOCITY_X); -NODES[3263].Fix(VELOCITY_Y); -NODES[3263].Fix(VELOCITY_Z); -NODES[3267].Fix(VELOCITY_X); -NODES[3267].Fix(VELOCITY_Y); -NODES[3267].Fix(VELOCITY_Z); -NODES[3286].Fix(VELOCITY_X); -NODES[3286].Fix(VELOCITY_Y); -NODES[3286].Fix(VELOCITY_Z); -NODES[3292].Fix(VELOCITY_X); -NODES[3292].Fix(VELOCITY_Y); -NODES[3292].Fix(VELOCITY_Z); -NODES[3308].Fix(VELOCITY_X); -NODES[3308].Fix(VELOCITY_Y); -NODES[3308].Fix(VELOCITY_Z); -NODES[3323].Fix(VELOCITY_X); -NODES[3323].Fix(VELOCITY_Y); -NODES[3323].Fix(VELOCITY_Z); -NODES[3328].Fix(VELOCITY_X); -NODES[3328].Fix(VELOCITY_Y); -NODES[3328].Fix(VELOCITY_Z); -NODES[3348].Fix(VELOCITY_X); -NODES[3348].Fix(VELOCITY_Y); -NODES[3348].Fix(VELOCITY_Z); -NODES[3349].Fix(VELOCITY_X); -NODES[3349].Fix(VELOCITY_Y); -NODES[3349].Fix(VELOCITY_Z); -NODES[3370].Fix(VELOCITY_X); -NODES[3370].Fix(VELOCITY_Y); -NODES[3370].Fix(VELOCITY_Z); -NODES[3375].Fix(VELOCITY_X); -NODES[3375].Fix(VELOCITY_Y); -NODES[3375].Fix(VELOCITY_Z); -NODES[3393].Fix(VELOCITY_X); -NODES[3393].Fix(VELOCITY_Y); -NODES[3393].Fix(VELOCITY_Z); -NODES[3401].Fix(VELOCITY_X); -NODES[3401].Fix(VELOCITY_Y); -NODES[3401].Fix(VELOCITY_Z); -NODES[3414].Fix(VELOCITY_X); -NODES[3414].Fix(VELOCITY_Y); -NODES[3414].Fix(VELOCITY_Z); -NODES[3426].Fix(VELOCITY_X); -NODES[3426].Fix(VELOCITY_Y); -NODES[3426].Fix(VELOCITY_Z); -NODES[3436].Fix(VELOCITY_X); -NODES[3436].Fix(VELOCITY_Y); -NODES[3436].Fix(VELOCITY_Z); -NODES[3457].Fix(VELOCITY_X); -NODES[3457].Fix(VELOCITY_Y); -NODES[3457].Fix(VELOCITY_Z); -NODES[3459].Fix(VELOCITY_X); -NODES[3459].Fix(VELOCITY_Y); -NODES[3459].Fix(VELOCITY_Z); -NODES[3477].Fix(VELOCITY_X); -NODES[3477].Fix(VELOCITY_Y); -NODES[3477].Fix(VELOCITY_Z); -NODES[3485].Fix(VELOCITY_X); -NODES[3485].Fix(VELOCITY_Y); -NODES[3485].Fix(VELOCITY_Z); -NODES[3495].Fix(VELOCITY_X); -NODES[3495].Fix(VELOCITY_Y); -NODES[3495].Fix(VELOCITY_Z); -NODES[3512].Fix(VELOCITY_X); -NODES[3512].Fix(VELOCITY_Y); -NODES[3512].Fix(VELOCITY_Z); -NODES[3518].Fix(VELOCITY_X); -NODES[3518].Fix(VELOCITY_Y); -NODES[3518].Fix(VELOCITY_Z); -NODES[3538].Fix(VELOCITY_X); -NODES[3538].Fix(VELOCITY_Y); -NODES[3538].Fix(VELOCITY_Z); -NODES[3541].Fix(VELOCITY_X); -NODES[3541].Fix(VELOCITY_Y); -NODES[3541].Fix(VELOCITY_Z); -NODES[3563].Fix(VELOCITY_X); -NODES[3563].Fix(VELOCITY_Y); -NODES[3563].Fix(VELOCITY_Z); -NODES[3564].Fix(VELOCITY_X); -NODES[3564].Fix(VELOCITY_Y); -NODES[3564].Fix(VELOCITY_Z); -NODES[3586].Fix(VELOCITY_X); -NODES[3586].Fix(VELOCITY_Y); -NODES[3586].Fix(VELOCITY_Z); -NODES[3587].Fix(VELOCITY_X); -NODES[3587].Fix(VELOCITY_Y); -NODES[3587].Fix(VELOCITY_Z); -NODES[3609].Fix(VELOCITY_X); -NODES[3609].Fix(VELOCITY_Y); -NODES[3609].Fix(VELOCITY_Z); -NODES[3617].Fix(VELOCITY_X); -NODES[3617].Fix(VELOCITY_Y); -NODES[3617].Fix(VELOCITY_Z); -NODES[3632].Fix(VELOCITY_X); -NODES[3632].Fix(VELOCITY_Y); -NODES[3632].Fix(VELOCITY_Z); -NODES[3648].Fix(VELOCITY_X); -NODES[3648].Fix(VELOCITY_Y); -NODES[3648].Fix(VELOCITY_Z); -NODES[3649].Fix(VELOCITY_X); -NODES[3649].Fix(VELOCITY_Y); -NODES[3649].Fix(VELOCITY_Z); -NODES[3650].Fix(VELOCITY_X); -NODES[3650].Fix(VELOCITY_Y); -NODES[3650].Fix(VELOCITY_Z); -NODES[3651].Fix(VELOCITY_X); -NODES[3651].Fix(VELOCITY_Y); -NODES[3651].Fix(VELOCITY_Z); -NODES[3653].Fix(VELOCITY_X); -NODES[3653].Fix(VELOCITY_Y); -NODES[3653].Fix(VELOCITY_Z); -NODES[3654].Fix(VELOCITY_X); -NODES[3654].Fix(VELOCITY_Y); -NODES[3654].Fix(VELOCITY_Z); -NODES[3656].Fix(VELOCITY_X); -NODES[3656].Fix(VELOCITY_Y); -NODES[3656].Fix(VELOCITY_Z); -NODES[3657].Fix(VELOCITY_X); -NODES[3657].Fix(VELOCITY_Y); -NODES[3657].Fix(VELOCITY_Z); -NODES[3659].Fix(VELOCITY_X); -NODES[3659].Fix(VELOCITY_Y); -NODES[3659].Fix(VELOCITY_Z); -NODES[3661].Fix(VELOCITY_X); -NODES[3661].Fix(VELOCITY_Y); -NODES[3661].Fix(VELOCITY_Z); -NODES[3664].Fix(VELOCITY_X); -NODES[3664].Fix(VELOCITY_Y); -NODES[3664].Fix(VELOCITY_Z); -NODES[3665].Fix(VELOCITY_X); -NODES[3665].Fix(VELOCITY_Y); -NODES[3665].Fix(VELOCITY_Z); -NODES[3666].Fix(VELOCITY_X); -NODES[3666].Fix(VELOCITY_Y); -NODES[3666].Fix(VELOCITY_Z); -NODES[3667].Fix(VELOCITY_X); -NODES[3667].Fix(VELOCITY_Y); -NODES[3667].Fix(VELOCITY_Z); -NODES[3668].Fix(VELOCITY_X); -NODES[3668].Fix(VELOCITY_Y); -NODES[3668].Fix(VELOCITY_Z); -NODES[3669].Fix(VELOCITY_X); -NODES[3669].Fix(VELOCITY_Y); -NODES[3669].Fix(VELOCITY_Z); -NODES[3670].Fix(VELOCITY_X); -NODES[3670].Fix(VELOCITY_Y); -NODES[3670].Fix(VELOCITY_Z); -NODES[3671].Fix(VELOCITY_X); -NODES[3671].Fix(VELOCITY_Y); -NODES[3671].Fix(VELOCITY_Z); -NODES[3683].Fix(VELOCITY_X); -NODES[3683].Fix(VELOCITY_Y); -NODES[3683].Fix(VELOCITY_Z); -NODES[3689].Fix(VELOCITY_X); -NODES[3689].Fix(VELOCITY_Y); -NODES[3689].Fix(VELOCITY_Z); -NODES[3692].Fix(VELOCITY_X); -NODES[3692].Fix(VELOCITY_Y); -NODES[3692].Fix(VELOCITY_Z); -NODES[3694].Fix(VELOCITY_X); -NODES[3694].Fix(VELOCITY_Y); -NODES[3694].Fix(VELOCITY_Z); -NODES[3697].Fix(VELOCITY_X); -NODES[3697].Fix(VELOCITY_Y); -NODES[3697].Fix(VELOCITY_Z); -NODES[3698].Fix(VELOCITY_X); -NODES[3698].Fix(VELOCITY_Y); -NODES[3698].Fix(VELOCITY_Z); -NODES[3699].Fix(VELOCITY_X); -NODES[3699].Fix(VELOCITY_Y); -NODES[3699].Fix(VELOCITY_Z); -NODES[3700].Fix(VELOCITY_X); -NODES[3700].Fix(VELOCITY_Y); -NODES[3700].Fix(VELOCITY_Z); -NODES[3705].Fix(VELOCITY_X); -NODES[3705].Fix(VELOCITY_Y); -NODES[3705].Fix(VELOCITY_Z); -NODES[3716].Fix(VELOCITY_X); -NODES[3716].Fix(VELOCITY_Y); -NODES[3716].Fix(VELOCITY_Z); -NODES[3721].Fix(VELOCITY_X); -NODES[3721].Fix(VELOCITY_Y); -NODES[3721].Fix(VELOCITY_Z); -NODES[3724].Fix(VELOCITY_X); -NODES[3724].Fix(VELOCITY_Y); -NODES[3724].Fix(VELOCITY_Z); -NODES[3725].Fix(VELOCITY_X); -NODES[3725].Fix(VELOCITY_Y); -NODES[3725].Fix(VELOCITY_Z); -NODES[3727].Fix(VELOCITY_X); -NODES[3727].Fix(VELOCITY_Y); -NODES[3727].Fix(VELOCITY_Z); -NODES[3729].Fix(VELOCITY_X); -NODES[3729].Fix(VELOCITY_Y); -NODES[3729].Fix(VELOCITY_Z); -NODES[3735].Fix(VELOCITY_X); -NODES[3735].Fix(VELOCITY_Y); -NODES[3735].Fix(VELOCITY_Z); -NODES[3745].Fix(VELOCITY_X); -NODES[3745].Fix(VELOCITY_Y); -NODES[3745].Fix(VELOCITY_Z); -NODES[3750].Fix(VELOCITY_X); -NODES[3750].Fix(VELOCITY_Y); -NODES[3750].Fix(VELOCITY_Z); -NODES[3751].Fix(VELOCITY_X); -NODES[3751].Fix(VELOCITY_Y); -NODES[3751].Fix(VELOCITY_Z); -NODES[3754].Fix(VELOCITY_X); -NODES[3754].Fix(VELOCITY_Y); -NODES[3754].Fix(VELOCITY_Z); -NODES[3755].Fix(VELOCITY_X); -NODES[3755].Fix(VELOCITY_Y); -NODES[3755].Fix(VELOCITY_Z); -NODES[3765].Fix(VELOCITY_X); -NODES[3765].Fix(VELOCITY_Y); -NODES[3765].Fix(VELOCITY_Z); -NODES[3774].Fix(VELOCITY_X); -NODES[3774].Fix(VELOCITY_Y); -NODES[3774].Fix(VELOCITY_Z); -NODES[3777].Fix(VELOCITY_X); -NODES[3777].Fix(VELOCITY_Y); -NODES[3777].Fix(VELOCITY_Z); -NODES[3778].Fix(VELOCITY_X); -NODES[3778].Fix(VELOCITY_Y); -NODES[3778].Fix(VELOCITY_Z); -NODES[3782].Fix(VELOCITY_X); -NODES[3782].Fix(VELOCITY_Y); -NODES[3782].Fix(VELOCITY_Z); -NODES[3783].Fix(VELOCITY_X); -NODES[3783].Fix(VELOCITY_Y); -NODES[3783].Fix(VELOCITY_Z); -NODES[3799].Fix(VELOCITY_X); -NODES[3799].Fix(VELOCITY_Y); -NODES[3799].Fix(VELOCITY_Z); -NODES[3803].Fix(VELOCITY_X); -NODES[3803].Fix(VELOCITY_Y); -NODES[3803].Fix(VELOCITY_Z); -NODES[3805].Fix(VELOCITY_X); -NODES[3805].Fix(VELOCITY_Y); -NODES[3805].Fix(VELOCITY_Z); -NODES[3807].Fix(VELOCITY_X); -NODES[3807].Fix(VELOCITY_Y); -NODES[3807].Fix(VELOCITY_Z); -NODES[3810].Fix(VELOCITY_X); -NODES[3810].Fix(VELOCITY_Y); -NODES[3810].Fix(VELOCITY_Z); -NODES[3824].Fix(VELOCITY_X); -NODES[3824].Fix(VELOCITY_Y); -NODES[3824].Fix(VELOCITY_Z); -NODES[3826].Fix(VELOCITY_X); -NODES[3826].Fix(VELOCITY_Y); -NODES[3826].Fix(VELOCITY_Z); -NODES[3831].Fix(VELOCITY_X); -NODES[3831].Fix(VELOCITY_Y); -NODES[3831].Fix(VELOCITY_Z); -NODES[3833].Fix(VELOCITY_X); -NODES[3833].Fix(VELOCITY_Y); -NODES[3833].Fix(VELOCITY_Z); -NODES[3843].Fix(VELOCITY_X); -NODES[3843].Fix(VELOCITY_Y); -NODES[3843].Fix(VELOCITY_Z); -NODES[3851].Fix(VELOCITY_X); -NODES[3851].Fix(VELOCITY_Y); -NODES[3851].Fix(VELOCITY_Z); -NODES[3852].Fix(VELOCITY_X); -NODES[3852].Fix(VELOCITY_Y); -NODES[3852].Fix(VELOCITY_Z); -NODES[3857].Fix(VELOCITY_X); -NODES[3857].Fix(VELOCITY_Y); -NODES[3857].Fix(VELOCITY_Z); -NODES[3862].Fix(VELOCITY_X); -NODES[3862].Fix(VELOCITY_Y); -NODES[3862].Fix(VELOCITY_Z); -NODES[3874].Fix(VELOCITY_X); -NODES[3874].Fix(VELOCITY_Y); -NODES[3874].Fix(VELOCITY_Z); -NODES[3875].Fix(VELOCITY_X); -NODES[3875].Fix(VELOCITY_Y); -NODES[3875].Fix(VELOCITY_Z); -NODES[3879].Fix(VELOCITY_X); -NODES[3879].Fix(VELOCITY_Y); -NODES[3879].Fix(VELOCITY_Z); -NODES[3888].Fix(VELOCITY_X); -NODES[3888].Fix(VELOCITY_Y); -NODES[3888].Fix(VELOCITY_Z); -NODES[3898].Fix(VELOCITY_X); -NODES[3898].Fix(VELOCITY_Y); -NODES[3898].Fix(VELOCITY_Z); -NODES[3900].Fix(VELOCITY_X); -NODES[3900].Fix(VELOCITY_Y); -NODES[3900].Fix(VELOCITY_Z); -NODES[3905].Fix(VELOCITY_X); -NODES[3905].Fix(VELOCITY_Y); -NODES[3905].Fix(VELOCITY_Z); -NODES[3912].Fix(VELOCITY_X); -NODES[3912].Fix(VELOCITY_Y); -NODES[3912].Fix(VELOCITY_Z); -NODES[3919].Fix(VELOCITY_X); -NODES[3919].Fix(VELOCITY_Y); -NODES[3919].Fix(VELOCITY_Z); -NODES[3923].Fix(VELOCITY_X); -NODES[3923].Fix(VELOCITY_Y); -NODES[3923].Fix(VELOCITY_Z); -NODES[3931].Fix(VELOCITY_X); -NODES[3931].Fix(VELOCITY_Y); -NODES[3931].Fix(VELOCITY_Z); -NODES[3939].Fix(VELOCITY_X); -NODES[3939].Fix(VELOCITY_Y); -NODES[3939].Fix(VELOCITY_Z); -NODES[3945].Fix(VELOCITY_X); -NODES[3945].Fix(VELOCITY_Y); -NODES[3945].Fix(VELOCITY_Z); -NODES[3950].Fix(VELOCITY_X); -NODES[3950].Fix(VELOCITY_Y); -NODES[3950].Fix(VELOCITY_Z); -NODES[3957].Fix(VELOCITY_X); -NODES[3957].Fix(VELOCITY_Y); -NODES[3957].Fix(VELOCITY_Z); -NODES[3965].Fix(VELOCITY_X); -NODES[3965].Fix(VELOCITY_Y); -NODES[3965].Fix(VELOCITY_Z); -NODES[3968].Fix(VELOCITY_X); -NODES[3968].Fix(VELOCITY_Y); -NODES[3968].Fix(VELOCITY_Z); -NODES[3976].Fix(VELOCITY_X); -NODES[3976].Fix(VELOCITY_Y); -NODES[3976].Fix(VELOCITY_Z); -NODES[3986].Fix(VELOCITY_X); -NODES[3986].Fix(VELOCITY_Y); -NODES[3986].Fix(VELOCITY_Z); -NODES[3990].Fix(VELOCITY_X); -NODES[3990].Fix(VELOCITY_Y); -NODES[3990].Fix(VELOCITY_Z); -NODES[3995].Fix(VELOCITY_X); -NODES[3995].Fix(VELOCITY_Y); -NODES[3995].Fix(VELOCITY_Z); -NODES[4003].Fix(VELOCITY_X); -NODES[4003].Fix(VELOCITY_Y); -NODES[4003].Fix(VELOCITY_Z); -NODES[4014].Fix(VELOCITY_X); -NODES[4014].Fix(VELOCITY_Y); -NODES[4014].Fix(VELOCITY_Z); -NODES[4015].Fix(VELOCITY_X); -NODES[4015].Fix(VELOCITY_Y); -NODES[4015].Fix(VELOCITY_Z); -NODES[4024].Fix(VELOCITY_X); -NODES[4024].Fix(VELOCITY_Y); -NODES[4024].Fix(VELOCITY_Z); -NODES[4033].Fix(VELOCITY_X); -NODES[4033].Fix(VELOCITY_Y); -NODES[4033].Fix(VELOCITY_Z); -NODES[4039].Fix(VELOCITY_X); -NODES[4039].Fix(VELOCITY_Y); -NODES[4039].Fix(VELOCITY_Z); -NODES[4044].Fix(VELOCITY_X); -NODES[4044].Fix(VELOCITY_Y); -NODES[4044].Fix(VELOCITY_Z); -NODES[4053].Fix(VELOCITY_X); -NODES[4053].Fix(VELOCITY_Y); -NODES[4053].Fix(VELOCITY_Z); -NODES[4061].Fix(VELOCITY_X); -NODES[4061].Fix(VELOCITY_Y); -NODES[4061].Fix(VELOCITY_Z); -NODES[4065].Fix(VELOCITY_X); -NODES[4065].Fix(VELOCITY_Y); -NODES[4065].Fix(VELOCITY_Z); -NODES[4072].Fix(VELOCITY_X); -NODES[4072].Fix(VELOCITY_Y); -NODES[4072].Fix(VELOCITY_Z); -NODES[4086].Fix(VELOCITY_X); -NODES[4086].Fix(VELOCITY_Y); -NODES[4086].Fix(VELOCITY_Z); -NODES[4087].Fix(VELOCITY_X); -NODES[4087].Fix(VELOCITY_Y); -NODES[4087].Fix(VELOCITY_Z); -NODES[4094].Fix(VELOCITY_X); -NODES[4094].Fix(VELOCITY_Y); -NODES[4094].Fix(VELOCITY_Z); -NODES[4106].Fix(VELOCITY_X); -NODES[4106].Fix(VELOCITY_Y); -NODES[4106].Fix(VELOCITY_Z); -NODES[4109].Fix(VELOCITY_X); -NODES[4109].Fix(VELOCITY_Y); -NODES[4109].Fix(VELOCITY_Z); -NODES[4118].Fix(VELOCITY_X); -NODES[4118].Fix(VELOCITY_Y); -NODES[4118].Fix(VELOCITY_Z); -NODES[4128].Fix(VELOCITY_X); -NODES[4128].Fix(VELOCITY_Y); -NODES[4128].Fix(VELOCITY_Z); -NODES[4132].Fix(VELOCITY_X); -NODES[4132].Fix(VELOCITY_Y); -NODES[4132].Fix(VELOCITY_Z); -NODES[4139].Fix(VELOCITY_X); -NODES[4139].Fix(VELOCITY_Y); -NODES[4139].Fix(VELOCITY_Z); -NODES[4149].Fix(VELOCITY_X); -NODES[4149].Fix(VELOCITY_Y); -NODES[4149].Fix(VELOCITY_Z); -NODES[4157].Fix(VELOCITY_X); -NODES[4157].Fix(VELOCITY_Y); -NODES[4157].Fix(VELOCITY_Z); -NODES[4163].Fix(VELOCITY_X); -NODES[4163].Fix(VELOCITY_Y); -NODES[4163].Fix(VELOCITY_Z); -NODES[4173].Fix(VELOCITY_X); -NODES[4173].Fix(VELOCITY_Y); -NODES[4173].Fix(VELOCITY_Z); -NODES[4180].Fix(VELOCITY_X); -NODES[4180].Fix(VELOCITY_Y); -NODES[4180].Fix(VELOCITY_Z); -NODES[4186].Fix(VELOCITY_X); -NODES[4186].Fix(VELOCITY_Y); -NODES[4186].Fix(VELOCITY_Z); -NODES[4196].Fix(VELOCITY_X); -NODES[4196].Fix(VELOCITY_Y); -NODES[4196].Fix(VELOCITY_Z); -NODES[4201].Fix(VELOCITY_X); -NODES[4201].Fix(VELOCITY_Y); -NODES[4201].Fix(VELOCITY_Z); -NODES[4207].Fix(VELOCITY_X); -NODES[4207].Fix(VELOCITY_Y); -NODES[4207].Fix(VELOCITY_Z); -NODES[4214].Fix(VELOCITY_X); -NODES[4214].Fix(VELOCITY_Y); -NODES[4214].Fix(VELOCITY_Z); -NODES[4222].Fix(VELOCITY_X); -NODES[4222].Fix(VELOCITY_Y); -NODES[4222].Fix(VELOCITY_Z); -NODES[4226].Fix(VELOCITY_X); -NODES[4226].Fix(VELOCITY_Y); -NODES[4226].Fix(VELOCITY_Z); -NODES[4234].Fix(VELOCITY_X); -NODES[4234].Fix(VELOCITY_Y); -NODES[4234].Fix(VELOCITY_Z); -NODES[4240].Fix(VELOCITY_X); -NODES[4240].Fix(VELOCITY_Y); -NODES[4240].Fix(VELOCITY_Z); -NODES[4242].Fix(VELOCITY_X); -NODES[4242].Fix(VELOCITY_Y); -NODES[4242].Fix(VELOCITY_Z); -NODES[4248].Fix(VELOCITY_X); -NODES[4248].Fix(VELOCITY_Y); -NODES[4248].Fix(VELOCITY_Z); -NODES[4255].Fix(VELOCITY_X); -NODES[4255].Fix(VELOCITY_Y); -NODES[4255].Fix(VELOCITY_Z); -NODES[4257].Fix(VELOCITY_X); -NODES[4257].Fix(VELOCITY_Y); -NODES[4257].Fix(VELOCITY_Z); -NODES[4263].Fix(VELOCITY_X); -NODES[4263].Fix(VELOCITY_Y); -NODES[4263].Fix(VELOCITY_Z); -NODES[4268].Fix(VELOCITY_X); -NODES[4268].Fix(VELOCITY_Y); -NODES[4268].Fix(VELOCITY_Z); -NODES[4270].Fix(VELOCITY_X); -NODES[4270].Fix(VELOCITY_Y); -NODES[4270].Fix(VELOCITY_Z); -NODES[4275].Fix(VELOCITY_X); -NODES[4275].Fix(VELOCITY_Y); -NODES[4275].Fix(VELOCITY_Z); -NODES[4276].Fix(VELOCITY_X); -NODES[4276].Fix(VELOCITY_Y); -NODES[4276].Fix(VELOCITY_Z); -NODES[4281].Fix(VELOCITY_X); -NODES[4281].Fix(VELOCITY_Y); -NODES[4281].Fix(VELOCITY_Z); -NODES[4284].Fix(VELOCITY_X); -NODES[4284].Fix(VELOCITY_Y); -NODES[4284].Fix(VELOCITY_Z); -NODES[4286].Fix(VELOCITY_X); -NODES[4286].Fix(VELOCITY_Y); -NODES[4286].Fix(VELOCITY_Z); -NODES[4289].Fix(VELOCITY_X); -NODES[4289].Fix(VELOCITY_Y); -NODES[4289].Fix(VELOCITY_Z); -NODES[4292].Fix(VELOCITY_X); -NODES[4292].Fix(VELOCITY_Y); -NODES[4292].Fix(VELOCITY_Z); -NODES[4293].Fix(VELOCITY_X); -NODES[4293].Fix(VELOCITY_Y); -NODES[4293].Fix(VELOCITY_Z); -NODES[4295].Fix(VELOCITY_X); -NODES[4295].Fix(VELOCITY_Y); -NODES[4295].Fix(VELOCITY_Z); -NODES[4296].Fix(VELOCITY_X); -NODES[4296].Fix(VELOCITY_Y); -NODES[4296].Fix(VELOCITY_Z); -NODES[4297].Fix(VELOCITY_X); -NODES[4297].Fix(VELOCITY_Y); -NODES[4297].Fix(VELOCITY_Z); -NODES[4298].Fix(VELOCITY_X); -NODES[4298].Fix(VELOCITY_Y); -NODES[4298].Fix(VELOCITY_Z); -NODES[4299].Fix(VELOCITY_X); -NODES[4299].Fix(VELOCITY_Y); -NODES[4299].Fix(VELOCITY_Z); -NODES[167].Fix(BODY_FORCE_X); -NODES[167].Fix(BODY_FORCE_Y); -NODES[167].Fix(BODY_FORCE_Z); -NODES[168].Fix(BODY_FORCE_X); -NODES[168].Fix(BODY_FORCE_Y); -NODES[168].Fix(BODY_FORCE_Z); -NODES[169].Fix(BODY_FORCE_X); -NODES[169].Fix(BODY_FORCE_Y); -NODES[169].Fix(BODY_FORCE_Z); -NODES[170].Fix(BODY_FORCE_X); -NODES[170].Fix(BODY_FORCE_Y); -NODES[170].Fix(BODY_FORCE_Z); -NODES[171].Fix(BODY_FORCE_X); -NODES[171].Fix(BODY_FORCE_Y); -NODES[171].Fix(BODY_FORCE_Z); -NODES[172].Fix(BODY_FORCE_X); -NODES[172].Fix(BODY_FORCE_Y); -NODES[172].Fix(BODY_FORCE_Z); -NODES[173].Fix(BODY_FORCE_X); -NODES[173].Fix(BODY_FORCE_Y); -NODES[173].Fix(BODY_FORCE_Z); -NODES[174].Fix(BODY_FORCE_X); -NODES[174].Fix(BODY_FORCE_Y); -NODES[174].Fix(BODY_FORCE_Z); -NODES[175].Fix(BODY_FORCE_X); -NODES[175].Fix(BODY_FORCE_Y); -NODES[175].Fix(BODY_FORCE_Z); -NODES[176].Fix(BODY_FORCE_X); -NODES[176].Fix(BODY_FORCE_Y); -NODES[176].Fix(BODY_FORCE_Z); -NODES[177].Fix(BODY_FORCE_X); -NODES[177].Fix(BODY_FORCE_Y); -NODES[177].Fix(BODY_FORCE_Z); -NODES[178].Fix(BODY_FORCE_X); -NODES[178].Fix(BODY_FORCE_Y); -NODES[178].Fix(BODY_FORCE_Z); -NODES[179].Fix(BODY_FORCE_X); -NODES[179].Fix(BODY_FORCE_Y); -NODES[179].Fix(BODY_FORCE_Z); -NODES[180].Fix(BODY_FORCE_X); -NODES[180].Fix(BODY_FORCE_Y); -NODES[180].Fix(BODY_FORCE_Z); -NODES[181].Fix(BODY_FORCE_X); -NODES[181].Fix(BODY_FORCE_Y); -NODES[181].Fix(BODY_FORCE_Z); -NODES[182].Fix(BODY_FORCE_X); -NODES[182].Fix(BODY_FORCE_Y); -NODES[182].Fix(BODY_FORCE_Z); -NODES[184].Fix(BODY_FORCE_X); -NODES[184].Fix(BODY_FORCE_Y); -NODES[184].Fix(BODY_FORCE_Z); -NODES[185].Fix(BODY_FORCE_X); -NODES[185].Fix(BODY_FORCE_Y); -NODES[185].Fix(BODY_FORCE_Z); -NODES[186].Fix(BODY_FORCE_X); -NODES[186].Fix(BODY_FORCE_Y); -NODES[186].Fix(BODY_FORCE_Z); -NODES[187].Fix(BODY_FORCE_X); -NODES[187].Fix(BODY_FORCE_Y); -NODES[187].Fix(BODY_FORCE_Z); -NODES[188].Fix(BODY_FORCE_X); -NODES[188].Fix(BODY_FORCE_Y); -NODES[188].Fix(BODY_FORCE_Z); -NODES[189].Fix(BODY_FORCE_X); -NODES[189].Fix(BODY_FORCE_Y); -NODES[189].Fix(BODY_FORCE_Z); -NODES[190].Fix(BODY_FORCE_X); -NODES[190].Fix(BODY_FORCE_Y); -NODES[190].Fix(BODY_FORCE_Z); -NODES[191].Fix(BODY_FORCE_X); -NODES[191].Fix(BODY_FORCE_Y); -NODES[191].Fix(BODY_FORCE_Z); -NODES[192].Fix(BODY_FORCE_X); -NODES[192].Fix(BODY_FORCE_Y); -NODES[192].Fix(BODY_FORCE_Z); -NODES[193].Fix(BODY_FORCE_X); -NODES[193].Fix(BODY_FORCE_Y); -NODES[193].Fix(BODY_FORCE_Z); -NODES[194].Fix(BODY_FORCE_X); -NODES[194].Fix(BODY_FORCE_Y); -NODES[194].Fix(BODY_FORCE_Z); -NODES[195].Fix(BODY_FORCE_X); -NODES[195].Fix(BODY_FORCE_Y); -NODES[195].Fix(BODY_FORCE_Z); -NODES[196].Fix(BODY_FORCE_X); -NODES[196].Fix(BODY_FORCE_Y); -NODES[196].Fix(BODY_FORCE_Z); -NODES[197].Fix(BODY_FORCE_X); -NODES[197].Fix(BODY_FORCE_Y); -NODES[197].Fix(BODY_FORCE_Z); -NODES[198].Fix(BODY_FORCE_X); -NODES[198].Fix(BODY_FORCE_Y); -NODES[198].Fix(BODY_FORCE_Z); -NODES[199].Fix(BODY_FORCE_X); -NODES[199].Fix(BODY_FORCE_Y); -NODES[199].Fix(BODY_FORCE_Z); -NODES[200].Fix(BODY_FORCE_X); -NODES[200].Fix(BODY_FORCE_Y); -NODES[200].Fix(BODY_FORCE_Z); -NODES[201].Fix(BODY_FORCE_X); -NODES[201].Fix(BODY_FORCE_Y); -NODES[201].Fix(BODY_FORCE_Z); -NODES[202].Fix(BODY_FORCE_X); -NODES[202].Fix(BODY_FORCE_Y); -NODES[202].Fix(BODY_FORCE_Z); -NODES[203].Fix(BODY_FORCE_X); -NODES[203].Fix(BODY_FORCE_Y); -NODES[203].Fix(BODY_FORCE_Z); -NODES[205].Fix(BODY_FORCE_X); -NODES[205].Fix(BODY_FORCE_Y); -NODES[205].Fix(BODY_FORCE_Z); -NODES[206].Fix(BODY_FORCE_X); -NODES[206].Fix(BODY_FORCE_Y); -NODES[206].Fix(BODY_FORCE_Z); -NODES[207].Fix(BODY_FORCE_X); -NODES[207].Fix(BODY_FORCE_Y); -NODES[207].Fix(BODY_FORCE_Z); -NODES[208].Fix(BODY_FORCE_X); -NODES[208].Fix(BODY_FORCE_Y); -NODES[208].Fix(BODY_FORCE_Z); -NODES[209].Fix(BODY_FORCE_X); -NODES[209].Fix(BODY_FORCE_Y); -NODES[209].Fix(BODY_FORCE_Z); -NODES[210].Fix(BODY_FORCE_X); -NODES[210].Fix(BODY_FORCE_Y); -NODES[210].Fix(BODY_FORCE_Z); -NODES[211].Fix(BODY_FORCE_X); -NODES[211].Fix(BODY_FORCE_Y); -NODES[211].Fix(BODY_FORCE_Z); -NODES[212].Fix(BODY_FORCE_X); -NODES[212].Fix(BODY_FORCE_Y); -NODES[212].Fix(BODY_FORCE_Z); -NODES[213].Fix(BODY_FORCE_X); -NODES[213].Fix(BODY_FORCE_Y); -NODES[213].Fix(BODY_FORCE_Z); -NODES[214].Fix(BODY_FORCE_X); -NODES[214].Fix(BODY_FORCE_Y); -NODES[214].Fix(BODY_FORCE_Z); -NODES[215].Fix(BODY_FORCE_X); -NODES[215].Fix(BODY_FORCE_Y); -NODES[215].Fix(BODY_FORCE_Z); -NODES[216].Fix(BODY_FORCE_X); -NODES[216].Fix(BODY_FORCE_Y); -NODES[216].Fix(BODY_FORCE_Z); -NODES[217].Fix(BODY_FORCE_X); -NODES[217].Fix(BODY_FORCE_Y); -NODES[217].Fix(BODY_FORCE_Z); -NODES[218].Fix(BODY_FORCE_X); -NODES[218].Fix(BODY_FORCE_Y); -NODES[218].Fix(BODY_FORCE_Z); -NODES[219].Fix(BODY_FORCE_X); -NODES[219].Fix(BODY_FORCE_Y); -NODES[219].Fix(BODY_FORCE_Z); -NODES[220].Fix(BODY_FORCE_X); -NODES[220].Fix(BODY_FORCE_Y); -NODES[220].Fix(BODY_FORCE_Z); -NODES[221].Fix(BODY_FORCE_X); -NODES[221].Fix(BODY_FORCE_Y); -NODES[221].Fix(BODY_FORCE_Z); -NODES[222].Fix(BODY_FORCE_X); -NODES[222].Fix(BODY_FORCE_Y); -NODES[222].Fix(BODY_FORCE_Z); -NODES[223].Fix(BODY_FORCE_X); -NODES[223].Fix(BODY_FORCE_Y); -NODES[223].Fix(BODY_FORCE_Z); -NODES[224].Fix(BODY_FORCE_X); -NODES[224].Fix(BODY_FORCE_Y); -NODES[224].Fix(BODY_FORCE_Z); -NODES[225].Fix(BODY_FORCE_X); -NODES[225].Fix(BODY_FORCE_Y); -NODES[225].Fix(BODY_FORCE_Z); -NODES[226].Fix(BODY_FORCE_X); -NODES[226].Fix(BODY_FORCE_Y); -NODES[226].Fix(BODY_FORCE_Z); -NODES[227].Fix(BODY_FORCE_X); -NODES[227].Fix(BODY_FORCE_Y); -NODES[227].Fix(BODY_FORCE_Z); -NODES[228].Fix(BODY_FORCE_X); -NODES[228].Fix(BODY_FORCE_Y); -NODES[228].Fix(BODY_FORCE_Z); -NODES[229].Fix(BODY_FORCE_X); -NODES[229].Fix(BODY_FORCE_Y); -NODES[229].Fix(BODY_FORCE_Z); -NODES[230].Fix(BODY_FORCE_X); -NODES[230].Fix(BODY_FORCE_Y); -NODES[230].Fix(BODY_FORCE_Z); -NODES[232].Fix(BODY_FORCE_X); -NODES[232].Fix(BODY_FORCE_Y); -NODES[232].Fix(BODY_FORCE_Z); -NODES[233].Fix(BODY_FORCE_X); -NODES[233].Fix(BODY_FORCE_Y); -NODES[233].Fix(BODY_FORCE_Z); -NODES[234].Fix(BODY_FORCE_X); -NODES[234].Fix(BODY_FORCE_Y); -NODES[234].Fix(BODY_FORCE_Z); -NODES[235].Fix(BODY_FORCE_X); -NODES[235].Fix(BODY_FORCE_Y); -NODES[235].Fix(BODY_FORCE_Z); -NODES[236].Fix(BODY_FORCE_X); -NODES[236].Fix(BODY_FORCE_Y); -NODES[236].Fix(BODY_FORCE_Z); -NODES[237].Fix(BODY_FORCE_X); -NODES[237].Fix(BODY_FORCE_Y); -NODES[237].Fix(BODY_FORCE_Z); -NODES[238].Fix(BODY_FORCE_X); -NODES[238].Fix(BODY_FORCE_Y); -NODES[238].Fix(BODY_FORCE_Z); -NODES[239].Fix(BODY_FORCE_X); -NODES[239].Fix(BODY_FORCE_Y); -NODES[239].Fix(BODY_FORCE_Z); -NODES[240].Fix(BODY_FORCE_X); -NODES[240].Fix(BODY_FORCE_Y); -NODES[240].Fix(BODY_FORCE_Z); -NODES[241].Fix(BODY_FORCE_X); -NODES[241].Fix(BODY_FORCE_Y); -NODES[241].Fix(BODY_FORCE_Z); -NODES[242].Fix(BODY_FORCE_X); -NODES[242].Fix(BODY_FORCE_Y); -NODES[242].Fix(BODY_FORCE_Z); -NODES[243].Fix(BODY_FORCE_X); -NODES[243].Fix(BODY_FORCE_Y); -NODES[243].Fix(BODY_FORCE_Z); -NODES[244].Fix(BODY_FORCE_X); -NODES[244].Fix(BODY_FORCE_Y); -NODES[244].Fix(BODY_FORCE_Z); -NODES[245].Fix(BODY_FORCE_X); -NODES[245].Fix(BODY_FORCE_Y); -NODES[245].Fix(BODY_FORCE_Z); -NODES[246].Fix(BODY_FORCE_X); -NODES[246].Fix(BODY_FORCE_Y); -NODES[246].Fix(BODY_FORCE_Z); -NODES[247].Fix(BODY_FORCE_X); -NODES[247].Fix(BODY_FORCE_Y); -NODES[247].Fix(BODY_FORCE_Z); -NODES[248].Fix(BODY_FORCE_X); -NODES[248].Fix(BODY_FORCE_Y); -NODES[248].Fix(BODY_FORCE_Z); -NODES[249].Fix(BODY_FORCE_X); -NODES[249].Fix(BODY_FORCE_Y); -NODES[249].Fix(BODY_FORCE_Z); -NODES[250].Fix(BODY_FORCE_X); -NODES[250].Fix(BODY_FORCE_Y); -NODES[250].Fix(BODY_FORCE_Z); -NODES[251].Fix(BODY_FORCE_X); -NODES[251].Fix(BODY_FORCE_Y); -NODES[251].Fix(BODY_FORCE_Z); -NODES[252].Fix(BODY_FORCE_X); -NODES[252].Fix(BODY_FORCE_Y); -NODES[252].Fix(BODY_FORCE_Z); -NODES[253].Fix(BODY_FORCE_X); -NODES[253].Fix(BODY_FORCE_Y); -NODES[253].Fix(BODY_FORCE_Z); -NODES[254].Fix(BODY_FORCE_X); -NODES[254].Fix(BODY_FORCE_Y); -NODES[254].Fix(BODY_FORCE_Z); -NODES[255].Fix(BODY_FORCE_X); -NODES[255].Fix(BODY_FORCE_Y); -NODES[255].Fix(BODY_FORCE_Z); -NODES[256].Fix(BODY_FORCE_X); -NODES[256].Fix(BODY_FORCE_Y); -NODES[256].Fix(BODY_FORCE_Z); -NODES[257].Fix(BODY_FORCE_X); -NODES[257].Fix(BODY_FORCE_Y); -NODES[257].Fix(BODY_FORCE_Z); -NODES[258].Fix(BODY_FORCE_X); -NODES[258].Fix(BODY_FORCE_Y); -NODES[258].Fix(BODY_FORCE_Z); -NODES[259].Fix(BODY_FORCE_X); -NODES[259].Fix(BODY_FORCE_Y); -NODES[259].Fix(BODY_FORCE_Z); -NODES[260].Fix(BODY_FORCE_X); -NODES[260].Fix(BODY_FORCE_Y); -NODES[260].Fix(BODY_FORCE_Z); -NODES[262].Fix(BODY_FORCE_X); -NODES[262].Fix(BODY_FORCE_Y); -NODES[262].Fix(BODY_FORCE_Z); -NODES[263].Fix(BODY_FORCE_X); -NODES[263].Fix(BODY_FORCE_Y); -NODES[263].Fix(BODY_FORCE_Z); -NODES[264].Fix(BODY_FORCE_X); -NODES[264].Fix(BODY_FORCE_Y); -NODES[264].Fix(BODY_FORCE_Z); -NODES[265].Fix(BODY_FORCE_X); -NODES[265].Fix(BODY_FORCE_Y); -NODES[265].Fix(BODY_FORCE_Z); -NODES[266].Fix(BODY_FORCE_X); -NODES[266].Fix(BODY_FORCE_Y); -NODES[266].Fix(BODY_FORCE_Z); -NODES[267].Fix(BODY_FORCE_X); -NODES[267].Fix(BODY_FORCE_Y); -NODES[267].Fix(BODY_FORCE_Z); -NODES[268].Fix(BODY_FORCE_X); -NODES[268].Fix(BODY_FORCE_Y); -NODES[268].Fix(BODY_FORCE_Z); -NODES[269].Fix(BODY_FORCE_X); -NODES[269].Fix(BODY_FORCE_Y); -NODES[269].Fix(BODY_FORCE_Z); -NODES[270].Fix(BODY_FORCE_X); -NODES[270].Fix(BODY_FORCE_Y); -NODES[270].Fix(BODY_FORCE_Z); -NODES[271].Fix(BODY_FORCE_X); -NODES[271].Fix(BODY_FORCE_Y); -NODES[271].Fix(BODY_FORCE_Z); -NODES[272].Fix(BODY_FORCE_X); -NODES[272].Fix(BODY_FORCE_Y); -NODES[272].Fix(BODY_FORCE_Z); -NODES[273].Fix(BODY_FORCE_X); -NODES[273].Fix(BODY_FORCE_Y); -NODES[273].Fix(BODY_FORCE_Z); -NODES[274].Fix(BODY_FORCE_X); -NODES[274].Fix(BODY_FORCE_Y); -NODES[274].Fix(BODY_FORCE_Z); -NODES[275].Fix(BODY_FORCE_X); -NODES[275].Fix(BODY_FORCE_Y); -NODES[275].Fix(BODY_FORCE_Z); -NODES[276].Fix(BODY_FORCE_X); -NODES[276].Fix(BODY_FORCE_Y); -NODES[276].Fix(BODY_FORCE_Z); -NODES[277].Fix(BODY_FORCE_X); -NODES[277].Fix(BODY_FORCE_Y); -NODES[277].Fix(BODY_FORCE_Z); -NODES[278].Fix(BODY_FORCE_X); -NODES[278].Fix(BODY_FORCE_Y); -NODES[278].Fix(BODY_FORCE_Z); -NODES[279].Fix(BODY_FORCE_X); -NODES[279].Fix(BODY_FORCE_Y); -NODES[279].Fix(BODY_FORCE_Z); -NODES[280].Fix(BODY_FORCE_X); -NODES[280].Fix(BODY_FORCE_Y); -NODES[280].Fix(BODY_FORCE_Z); -NODES[281].Fix(BODY_FORCE_X); -NODES[281].Fix(BODY_FORCE_Y); -NODES[281].Fix(BODY_FORCE_Z); -NODES[282].Fix(BODY_FORCE_X); -NODES[282].Fix(BODY_FORCE_Y); -NODES[282].Fix(BODY_FORCE_Z); -NODES[283].Fix(BODY_FORCE_X); -NODES[283].Fix(BODY_FORCE_Y); -NODES[283].Fix(BODY_FORCE_Z); -NODES[284].Fix(BODY_FORCE_X); -NODES[284].Fix(BODY_FORCE_Y); -NODES[284].Fix(BODY_FORCE_Z); -NODES[285].Fix(BODY_FORCE_X); -NODES[285].Fix(BODY_FORCE_Y); -NODES[285].Fix(BODY_FORCE_Z); -NODES[286].Fix(BODY_FORCE_X); -NODES[286].Fix(BODY_FORCE_Y); -NODES[286].Fix(BODY_FORCE_Z); -NODES[287].Fix(BODY_FORCE_X); -NODES[287].Fix(BODY_FORCE_Y); -NODES[287].Fix(BODY_FORCE_Z); -NODES[288].Fix(BODY_FORCE_X); -NODES[288].Fix(BODY_FORCE_Y); -NODES[288].Fix(BODY_FORCE_Z); -NODES[289].Fix(BODY_FORCE_X); -NODES[289].Fix(BODY_FORCE_Y); -NODES[289].Fix(BODY_FORCE_Z); -NODES[290].Fix(BODY_FORCE_X); -NODES[290].Fix(BODY_FORCE_Y); -NODES[290].Fix(BODY_FORCE_Z); -NODES[291].Fix(BODY_FORCE_X); -NODES[291].Fix(BODY_FORCE_Y); -NODES[291].Fix(BODY_FORCE_Z); -NODES[292].Fix(BODY_FORCE_X); -NODES[292].Fix(BODY_FORCE_Y); -NODES[292].Fix(BODY_FORCE_Z); -NODES[293].Fix(BODY_FORCE_X); -NODES[293].Fix(BODY_FORCE_Y); -NODES[293].Fix(BODY_FORCE_Z); -NODES[294].Fix(BODY_FORCE_X); -NODES[294].Fix(BODY_FORCE_Y); -NODES[294].Fix(BODY_FORCE_Z); -NODES[295].Fix(BODY_FORCE_X); -NODES[295].Fix(BODY_FORCE_Y); -NODES[295].Fix(BODY_FORCE_Z); -NODES[296].Fix(BODY_FORCE_X); -NODES[296].Fix(BODY_FORCE_Y); -NODES[296].Fix(BODY_FORCE_Z); -NODES[297].Fix(BODY_FORCE_X); -NODES[297].Fix(BODY_FORCE_Y); -NODES[297].Fix(BODY_FORCE_Z); -NODES[298].Fix(BODY_FORCE_X); -NODES[298].Fix(BODY_FORCE_Y); -NODES[298].Fix(BODY_FORCE_Z); -NODES[300].Fix(BODY_FORCE_X); -NODES[300].Fix(BODY_FORCE_Y); -NODES[300].Fix(BODY_FORCE_Z); -NODES[301].Fix(BODY_FORCE_X); -NODES[301].Fix(BODY_FORCE_Y); -NODES[301].Fix(BODY_FORCE_Z); -NODES[302].Fix(BODY_FORCE_X); -NODES[302].Fix(BODY_FORCE_Y); -NODES[302].Fix(BODY_FORCE_Z); -NODES[303].Fix(BODY_FORCE_X); -NODES[303].Fix(BODY_FORCE_Y); -NODES[303].Fix(BODY_FORCE_Z); -NODES[304].Fix(BODY_FORCE_X); -NODES[304].Fix(BODY_FORCE_Y); -NODES[304].Fix(BODY_FORCE_Z); -NODES[305].Fix(BODY_FORCE_X); -NODES[305].Fix(BODY_FORCE_Y); -NODES[305].Fix(BODY_FORCE_Z); -NODES[306].Fix(BODY_FORCE_X); -NODES[306].Fix(BODY_FORCE_Y); -NODES[306].Fix(BODY_FORCE_Z); -NODES[307].Fix(BODY_FORCE_X); -NODES[307].Fix(BODY_FORCE_Y); -NODES[307].Fix(BODY_FORCE_Z); -NODES[308].Fix(BODY_FORCE_X); -NODES[308].Fix(BODY_FORCE_Y); -NODES[308].Fix(BODY_FORCE_Z); -NODES[309].Fix(BODY_FORCE_X); -NODES[309].Fix(BODY_FORCE_Y); -NODES[309].Fix(BODY_FORCE_Z); -NODES[310].Fix(BODY_FORCE_X); -NODES[310].Fix(BODY_FORCE_Y); -NODES[310].Fix(BODY_FORCE_Z); -NODES[311].Fix(BODY_FORCE_X); -NODES[311].Fix(BODY_FORCE_Y); -NODES[311].Fix(BODY_FORCE_Z); -NODES[312].Fix(BODY_FORCE_X); -NODES[312].Fix(BODY_FORCE_Y); -NODES[312].Fix(BODY_FORCE_Z); -NODES[313].Fix(BODY_FORCE_X); -NODES[313].Fix(BODY_FORCE_Y); -NODES[313].Fix(BODY_FORCE_Z); -NODES[314].Fix(BODY_FORCE_X); -NODES[314].Fix(BODY_FORCE_Y); -NODES[314].Fix(BODY_FORCE_Z); -NODES[315].Fix(BODY_FORCE_X); -NODES[315].Fix(BODY_FORCE_Y); -NODES[315].Fix(BODY_FORCE_Z); -NODES[316].Fix(BODY_FORCE_X); -NODES[316].Fix(BODY_FORCE_Y); -NODES[316].Fix(BODY_FORCE_Z); -NODES[317].Fix(BODY_FORCE_X); -NODES[317].Fix(BODY_FORCE_Y); -NODES[317].Fix(BODY_FORCE_Z); -NODES[318].Fix(BODY_FORCE_X); -NODES[318].Fix(BODY_FORCE_Y); -NODES[318].Fix(BODY_FORCE_Z); -NODES[319].Fix(BODY_FORCE_X); -NODES[319].Fix(BODY_FORCE_Y); -NODES[319].Fix(BODY_FORCE_Z); -NODES[320].Fix(BODY_FORCE_X); -NODES[320].Fix(BODY_FORCE_Y); -NODES[320].Fix(BODY_FORCE_Z); -NODES[321].Fix(BODY_FORCE_X); -NODES[321].Fix(BODY_FORCE_Y); -NODES[321].Fix(BODY_FORCE_Z); -NODES[322].Fix(BODY_FORCE_X); -NODES[322].Fix(BODY_FORCE_Y); -NODES[322].Fix(BODY_FORCE_Z); -NODES[323].Fix(BODY_FORCE_X); -NODES[323].Fix(BODY_FORCE_Y); -NODES[323].Fix(BODY_FORCE_Z); -NODES[324].Fix(BODY_FORCE_X); -NODES[324].Fix(BODY_FORCE_Y); -NODES[324].Fix(BODY_FORCE_Z); -NODES[325].Fix(BODY_FORCE_X); -NODES[325].Fix(BODY_FORCE_Y); -NODES[325].Fix(BODY_FORCE_Z); -NODES[326].Fix(BODY_FORCE_X); -NODES[326].Fix(BODY_FORCE_Y); -NODES[326].Fix(BODY_FORCE_Z); -NODES[327].Fix(BODY_FORCE_X); -NODES[327].Fix(BODY_FORCE_Y); -NODES[327].Fix(BODY_FORCE_Z); -NODES[328].Fix(BODY_FORCE_X); -NODES[328].Fix(BODY_FORCE_Y); -NODES[328].Fix(BODY_FORCE_Z); -NODES[329].Fix(BODY_FORCE_X); -NODES[329].Fix(BODY_FORCE_Y); -NODES[329].Fix(BODY_FORCE_Z); -NODES[330].Fix(BODY_FORCE_X); -NODES[330].Fix(BODY_FORCE_Y); -NODES[330].Fix(BODY_FORCE_Z); -NODES[331].Fix(BODY_FORCE_X); -NODES[331].Fix(BODY_FORCE_Y); -NODES[331].Fix(BODY_FORCE_Z); -NODES[332].Fix(BODY_FORCE_X); -NODES[332].Fix(BODY_FORCE_Y); -NODES[332].Fix(BODY_FORCE_Z); -NODES[333].Fix(BODY_FORCE_X); -NODES[333].Fix(BODY_FORCE_Y); -NODES[333].Fix(BODY_FORCE_Z); -NODES[334].Fix(BODY_FORCE_X); -NODES[334].Fix(BODY_FORCE_Y); -NODES[334].Fix(BODY_FORCE_Z); -NODES[335].Fix(BODY_FORCE_X); -NODES[335].Fix(BODY_FORCE_Y); -NODES[335].Fix(BODY_FORCE_Z); -NODES[336].Fix(BODY_FORCE_X); -NODES[336].Fix(BODY_FORCE_Y); -NODES[336].Fix(BODY_FORCE_Z); -NODES[338].Fix(BODY_FORCE_X); -NODES[338].Fix(BODY_FORCE_Y); -NODES[338].Fix(BODY_FORCE_Z); -NODES[339].Fix(BODY_FORCE_X); -NODES[339].Fix(BODY_FORCE_Y); -NODES[339].Fix(BODY_FORCE_Z); -NODES[340].Fix(BODY_FORCE_X); -NODES[340].Fix(BODY_FORCE_Y); -NODES[340].Fix(BODY_FORCE_Z); -NODES[341].Fix(BODY_FORCE_X); -NODES[341].Fix(BODY_FORCE_Y); -NODES[341].Fix(BODY_FORCE_Z); -NODES[342].Fix(BODY_FORCE_X); -NODES[342].Fix(BODY_FORCE_Y); -NODES[342].Fix(BODY_FORCE_Z); -NODES[343].Fix(BODY_FORCE_X); -NODES[343].Fix(BODY_FORCE_Y); -NODES[343].Fix(BODY_FORCE_Z); -NODES[344].Fix(BODY_FORCE_X); -NODES[344].Fix(BODY_FORCE_Y); -NODES[344].Fix(BODY_FORCE_Z); -NODES[345].Fix(BODY_FORCE_X); -NODES[345].Fix(BODY_FORCE_Y); -NODES[345].Fix(BODY_FORCE_Z); -NODES[346].Fix(BODY_FORCE_X); -NODES[346].Fix(BODY_FORCE_Y); -NODES[346].Fix(BODY_FORCE_Z); -NODES[347].Fix(BODY_FORCE_X); -NODES[347].Fix(BODY_FORCE_Y); -NODES[347].Fix(BODY_FORCE_Z); -NODES[348].Fix(BODY_FORCE_X); -NODES[348].Fix(BODY_FORCE_Y); -NODES[348].Fix(BODY_FORCE_Z); -NODES[349].Fix(BODY_FORCE_X); -NODES[349].Fix(BODY_FORCE_Y); -NODES[349].Fix(BODY_FORCE_Z); -NODES[350].Fix(BODY_FORCE_X); -NODES[350].Fix(BODY_FORCE_Y); -NODES[350].Fix(BODY_FORCE_Z); -NODES[351].Fix(BODY_FORCE_X); -NODES[351].Fix(BODY_FORCE_Y); -NODES[351].Fix(BODY_FORCE_Z); -NODES[352].Fix(BODY_FORCE_X); -NODES[352].Fix(BODY_FORCE_Y); -NODES[352].Fix(BODY_FORCE_Z); -NODES[353].Fix(BODY_FORCE_X); -NODES[353].Fix(BODY_FORCE_Y); -NODES[353].Fix(BODY_FORCE_Z); -NODES[354].Fix(BODY_FORCE_X); -NODES[354].Fix(BODY_FORCE_Y); -NODES[354].Fix(BODY_FORCE_Z); -NODES[355].Fix(BODY_FORCE_X); -NODES[355].Fix(BODY_FORCE_Y); -NODES[355].Fix(BODY_FORCE_Z); -NODES[356].Fix(BODY_FORCE_X); -NODES[356].Fix(BODY_FORCE_Y); -NODES[356].Fix(BODY_FORCE_Z); -NODES[357].Fix(BODY_FORCE_X); -NODES[357].Fix(BODY_FORCE_Y); -NODES[357].Fix(BODY_FORCE_Z); -NODES[358].Fix(BODY_FORCE_X); -NODES[358].Fix(BODY_FORCE_Y); -NODES[358].Fix(BODY_FORCE_Z); -NODES[359].Fix(BODY_FORCE_X); -NODES[359].Fix(BODY_FORCE_Y); -NODES[359].Fix(BODY_FORCE_Z); -NODES[360].Fix(BODY_FORCE_X); -NODES[360].Fix(BODY_FORCE_Y); -NODES[360].Fix(BODY_FORCE_Z); -NODES[361].Fix(BODY_FORCE_X); -NODES[361].Fix(BODY_FORCE_Y); -NODES[361].Fix(BODY_FORCE_Z); -NODES[362].Fix(BODY_FORCE_X); -NODES[362].Fix(BODY_FORCE_Y); -NODES[362].Fix(BODY_FORCE_Z); -NODES[363].Fix(BODY_FORCE_X); -NODES[363].Fix(BODY_FORCE_Y); -NODES[363].Fix(BODY_FORCE_Z); -NODES[364].Fix(BODY_FORCE_X); -NODES[364].Fix(BODY_FORCE_Y); -NODES[364].Fix(BODY_FORCE_Z); -NODES[365].Fix(BODY_FORCE_X); -NODES[365].Fix(BODY_FORCE_Y); -NODES[365].Fix(BODY_FORCE_Z); -NODES[366].Fix(BODY_FORCE_X); -NODES[366].Fix(BODY_FORCE_Y); -NODES[366].Fix(BODY_FORCE_Z); -NODES[367].Fix(BODY_FORCE_X); -NODES[367].Fix(BODY_FORCE_Y); -NODES[367].Fix(BODY_FORCE_Z); -NODES[368].Fix(BODY_FORCE_X); -NODES[368].Fix(BODY_FORCE_Y); -NODES[368].Fix(BODY_FORCE_Z); -NODES[369].Fix(BODY_FORCE_X); -NODES[369].Fix(BODY_FORCE_Y); -NODES[369].Fix(BODY_FORCE_Z); -NODES[370].Fix(BODY_FORCE_X); -NODES[370].Fix(BODY_FORCE_Y); -NODES[370].Fix(BODY_FORCE_Z); -NODES[371].Fix(BODY_FORCE_X); -NODES[371].Fix(BODY_FORCE_Y); -NODES[371].Fix(BODY_FORCE_Z); -NODES[372].Fix(BODY_FORCE_X); -NODES[372].Fix(BODY_FORCE_Y); -NODES[372].Fix(BODY_FORCE_Z); -NODES[373].Fix(BODY_FORCE_X); -NODES[373].Fix(BODY_FORCE_Y); -NODES[373].Fix(BODY_FORCE_Z); -NODES[374].Fix(BODY_FORCE_X); -NODES[374].Fix(BODY_FORCE_Y); -NODES[374].Fix(BODY_FORCE_Z); -NODES[375].Fix(BODY_FORCE_X); -NODES[375].Fix(BODY_FORCE_Y); -NODES[375].Fix(BODY_FORCE_Z); -NODES[376].Fix(BODY_FORCE_X); -NODES[376].Fix(BODY_FORCE_Y); -NODES[376].Fix(BODY_FORCE_Z); -NODES[377].Fix(BODY_FORCE_X); -NODES[377].Fix(BODY_FORCE_Y); -NODES[377].Fix(BODY_FORCE_Z); -NODES[378].Fix(BODY_FORCE_X); -NODES[378].Fix(BODY_FORCE_Y); -NODES[378].Fix(BODY_FORCE_Z); -NODES[379].Fix(BODY_FORCE_X); -NODES[379].Fix(BODY_FORCE_Y); -NODES[379].Fix(BODY_FORCE_Z); -NODES[380].Fix(BODY_FORCE_X); -NODES[380].Fix(BODY_FORCE_Y); -NODES[380].Fix(BODY_FORCE_Z); -NODES[382].Fix(BODY_FORCE_X); -NODES[382].Fix(BODY_FORCE_Y); -NODES[382].Fix(BODY_FORCE_Z); -NODES[383].Fix(BODY_FORCE_X); -NODES[383].Fix(BODY_FORCE_Y); -NODES[383].Fix(BODY_FORCE_Z); -NODES[384].Fix(BODY_FORCE_X); -NODES[384].Fix(BODY_FORCE_Y); -NODES[384].Fix(BODY_FORCE_Z); -NODES[385].Fix(BODY_FORCE_X); -NODES[385].Fix(BODY_FORCE_Y); -NODES[385].Fix(BODY_FORCE_Z); -NODES[386].Fix(BODY_FORCE_X); -NODES[386].Fix(BODY_FORCE_Y); -NODES[386].Fix(BODY_FORCE_Z); -NODES[387].Fix(BODY_FORCE_X); -NODES[387].Fix(BODY_FORCE_Y); -NODES[387].Fix(BODY_FORCE_Z); -NODES[388].Fix(BODY_FORCE_X); -NODES[388].Fix(BODY_FORCE_Y); -NODES[388].Fix(BODY_FORCE_Z); -NODES[389].Fix(BODY_FORCE_X); -NODES[389].Fix(BODY_FORCE_Y); -NODES[389].Fix(BODY_FORCE_Z); -NODES[390].Fix(BODY_FORCE_X); -NODES[390].Fix(BODY_FORCE_Y); -NODES[390].Fix(BODY_FORCE_Z); -NODES[391].Fix(BODY_FORCE_X); -NODES[391].Fix(BODY_FORCE_Y); -NODES[391].Fix(BODY_FORCE_Z); -NODES[392].Fix(BODY_FORCE_X); -NODES[392].Fix(BODY_FORCE_Y); -NODES[392].Fix(BODY_FORCE_Z); -NODES[393].Fix(BODY_FORCE_X); -NODES[393].Fix(BODY_FORCE_Y); -NODES[393].Fix(BODY_FORCE_Z); -NODES[394].Fix(BODY_FORCE_X); -NODES[394].Fix(BODY_FORCE_Y); -NODES[394].Fix(BODY_FORCE_Z); -NODES[395].Fix(BODY_FORCE_X); -NODES[395].Fix(BODY_FORCE_Y); -NODES[395].Fix(BODY_FORCE_Z); -NODES[396].Fix(BODY_FORCE_X); -NODES[396].Fix(BODY_FORCE_Y); -NODES[396].Fix(BODY_FORCE_Z); -NODES[397].Fix(BODY_FORCE_X); -NODES[397].Fix(BODY_FORCE_Y); -NODES[397].Fix(BODY_FORCE_Z); -NODES[398].Fix(BODY_FORCE_X); -NODES[398].Fix(BODY_FORCE_Y); -NODES[398].Fix(BODY_FORCE_Z); -NODES[399].Fix(BODY_FORCE_X); -NODES[399].Fix(BODY_FORCE_Y); -NODES[399].Fix(BODY_FORCE_Z); -NODES[400].Fix(BODY_FORCE_X); -NODES[400].Fix(BODY_FORCE_Y); -NODES[400].Fix(BODY_FORCE_Z); -NODES[401].Fix(BODY_FORCE_X); -NODES[401].Fix(BODY_FORCE_Y); -NODES[401].Fix(BODY_FORCE_Z); -NODES[402].Fix(BODY_FORCE_X); -NODES[402].Fix(BODY_FORCE_Y); -NODES[402].Fix(BODY_FORCE_Z); -NODES[403].Fix(BODY_FORCE_X); -NODES[403].Fix(BODY_FORCE_Y); -NODES[403].Fix(BODY_FORCE_Z); -NODES[404].Fix(BODY_FORCE_X); -NODES[404].Fix(BODY_FORCE_Y); -NODES[404].Fix(BODY_FORCE_Z); -NODES[405].Fix(BODY_FORCE_X); -NODES[405].Fix(BODY_FORCE_Y); -NODES[405].Fix(BODY_FORCE_Z); -NODES[406].Fix(BODY_FORCE_X); -NODES[406].Fix(BODY_FORCE_Y); -NODES[406].Fix(BODY_FORCE_Z); -NODES[407].Fix(BODY_FORCE_X); -NODES[407].Fix(BODY_FORCE_Y); -NODES[407].Fix(BODY_FORCE_Z); -NODES[408].Fix(BODY_FORCE_X); -NODES[408].Fix(BODY_FORCE_Y); -NODES[408].Fix(BODY_FORCE_Z); -NODES[409].Fix(BODY_FORCE_X); -NODES[409].Fix(BODY_FORCE_Y); -NODES[409].Fix(BODY_FORCE_Z); -NODES[410].Fix(BODY_FORCE_X); -NODES[410].Fix(BODY_FORCE_Y); -NODES[410].Fix(BODY_FORCE_Z); -NODES[411].Fix(BODY_FORCE_X); -NODES[411].Fix(BODY_FORCE_Y); -NODES[411].Fix(BODY_FORCE_Z); -NODES[412].Fix(BODY_FORCE_X); -NODES[412].Fix(BODY_FORCE_Y); -NODES[412].Fix(BODY_FORCE_Z); -NODES[413].Fix(BODY_FORCE_X); -NODES[413].Fix(BODY_FORCE_Y); -NODES[413].Fix(BODY_FORCE_Z); -NODES[414].Fix(BODY_FORCE_X); -NODES[414].Fix(BODY_FORCE_Y); -NODES[414].Fix(BODY_FORCE_Z); -NODES[415].Fix(BODY_FORCE_X); -NODES[415].Fix(BODY_FORCE_Y); -NODES[415].Fix(BODY_FORCE_Z); -NODES[416].Fix(BODY_FORCE_X); -NODES[416].Fix(BODY_FORCE_Y); -NODES[416].Fix(BODY_FORCE_Z); -NODES[417].Fix(BODY_FORCE_X); -NODES[417].Fix(BODY_FORCE_Y); -NODES[417].Fix(BODY_FORCE_Z); -NODES[418].Fix(BODY_FORCE_X); -NODES[418].Fix(BODY_FORCE_Y); -NODES[418].Fix(BODY_FORCE_Z); -NODES[419].Fix(BODY_FORCE_X); -NODES[419].Fix(BODY_FORCE_Y); -NODES[419].Fix(BODY_FORCE_Z); -NODES[420].Fix(BODY_FORCE_X); -NODES[420].Fix(BODY_FORCE_Y); -NODES[420].Fix(BODY_FORCE_Z); -NODES[421].Fix(BODY_FORCE_X); -NODES[421].Fix(BODY_FORCE_Y); -NODES[421].Fix(BODY_FORCE_Z); -NODES[422].Fix(BODY_FORCE_X); -NODES[422].Fix(BODY_FORCE_Y); -NODES[422].Fix(BODY_FORCE_Z); -NODES[423].Fix(BODY_FORCE_X); -NODES[423].Fix(BODY_FORCE_Y); -NODES[423].Fix(BODY_FORCE_Z); -NODES[424].Fix(BODY_FORCE_X); -NODES[424].Fix(BODY_FORCE_Y); -NODES[424].Fix(BODY_FORCE_Z); -NODES[426].Fix(BODY_FORCE_X); -NODES[426].Fix(BODY_FORCE_Y); -NODES[426].Fix(BODY_FORCE_Z); -NODES[427].Fix(BODY_FORCE_X); -NODES[427].Fix(BODY_FORCE_Y); -NODES[427].Fix(BODY_FORCE_Z); -NODES[428].Fix(BODY_FORCE_X); -NODES[428].Fix(BODY_FORCE_Y); -NODES[428].Fix(BODY_FORCE_Z); -NODES[429].Fix(BODY_FORCE_X); -NODES[429].Fix(BODY_FORCE_Y); -NODES[429].Fix(BODY_FORCE_Z); -NODES[430].Fix(BODY_FORCE_X); -NODES[430].Fix(BODY_FORCE_Y); -NODES[430].Fix(BODY_FORCE_Z); -NODES[431].Fix(BODY_FORCE_X); -NODES[431].Fix(BODY_FORCE_Y); -NODES[431].Fix(BODY_FORCE_Z); -NODES[432].Fix(BODY_FORCE_X); -NODES[432].Fix(BODY_FORCE_Y); -NODES[432].Fix(BODY_FORCE_Z); -NODES[433].Fix(BODY_FORCE_X); -NODES[433].Fix(BODY_FORCE_Y); -NODES[433].Fix(BODY_FORCE_Z); -NODES[434].Fix(BODY_FORCE_X); -NODES[434].Fix(BODY_FORCE_Y); -NODES[434].Fix(BODY_FORCE_Z); -NODES[435].Fix(BODY_FORCE_X); -NODES[435].Fix(BODY_FORCE_Y); -NODES[435].Fix(BODY_FORCE_Z); -NODES[436].Fix(BODY_FORCE_X); -NODES[436].Fix(BODY_FORCE_Y); -NODES[436].Fix(BODY_FORCE_Z); -NODES[437].Fix(BODY_FORCE_X); -NODES[437].Fix(BODY_FORCE_Y); -NODES[437].Fix(BODY_FORCE_Z); -NODES[438].Fix(BODY_FORCE_X); -NODES[438].Fix(BODY_FORCE_Y); -NODES[438].Fix(BODY_FORCE_Z); -NODES[439].Fix(BODY_FORCE_X); -NODES[439].Fix(BODY_FORCE_Y); -NODES[439].Fix(BODY_FORCE_Z); -NODES[440].Fix(BODY_FORCE_X); -NODES[440].Fix(BODY_FORCE_Y); -NODES[440].Fix(BODY_FORCE_Z); -NODES[441].Fix(BODY_FORCE_X); -NODES[441].Fix(BODY_FORCE_Y); -NODES[441].Fix(BODY_FORCE_Z); -NODES[442].Fix(BODY_FORCE_X); -NODES[442].Fix(BODY_FORCE_Y); -NODES[442].Fix(BODY_FORCE_Z); -NODES[443].Fix(BODY_FORCE_X); -NODES[443].Fix(BODY_FORCE_Y); -NODES[443].Fix(BODY_FORCE_Z); -NODES[444].Fix(BODY_FORCE_X); -NODES[444].Fix(BODY_FORCE_Y); -NODES[444].Fix(BODY_FORCE_Z); -NODES[445].Fix(BODY_FORCE_X); -NODES[445].Fix(BODY_FORCE_Y); -NODES[445].Fix(BODY_FORCE_Z); -NODES[446].Fix(BODY_FORCE_X); -NODES[446].Fix(BODY_FORCE_Y); -NODES[446].Fix(BODY_FORCE_Z); -NODES[447].Fix(BODY_FORCE_X); -NODES[447].Fix(BODY_FORCE_Y); -NODES[447].Fix(BODY_FORCE_Z); -NODES[448].Fix(BODY_FORCE_X); -NODES[448].Fix(BODY_FORCE_Y); -NODES[448].Fix(BODY_FORCE_Z); -NODES[449].Fix(BODY_FORCE_X); -NODES[449].Fix(BODY_FORCE_Y); -NODES[449].Fix(BODY_FORCE_Z); -NODES[450].Fix(BODY_FORCE_X); -NODES[450].Fix(BODY_FORCE_Y); -NODES[450].Fix(BODY_FORCE_Z); -NODES[451].Fix(BODY_FORCE_X); -NODES[451].Fix(BODY_FORCE_Y); -NODES[451].Fix(BODY_FORCE_Z); -NODES[452].Fix(BODY_FORCE_X); -NODES[452].Fix(BODY_FORCE_Y); -NODES[452].Fix(BODY_FORCE_Z); -NODES[453].Fix(BODY_FORCE_X); -NODES[453].Fix(BODY_FORCE_Y); -NODES[453].Fix(BODY_FORCE_Z); -NODES[454].Fix(BODY_FORCE_X); -NODES[454].Fix(BODY_FORCE_Y); -NODES[454].Fix(BODY_FORCE_Z); -NODES[455].Fix(BODY_FORCE_X); -NODES[455].Fix(BODY_FORCE_Y); -NODES[455].Fix(BODY_FORCE_Z); -NODES[456].Fix(BODY_FORCE_X); -NODES[456].Fix(BODY_FORCE_Y); -NODES[456].Fix(BODY_FORCE_Z); -NODES[457].Fix(BODY_FORCE_X); -NODES[457].Fix(BODY_FORCE_Y); -NODES[457].Fix(BODY_FORCE_Z); -NODES[458].Fix(BODY_FORCE_X); -NODES[458].Fix(BODY_FORCE_Y); -NODES[458].Fix(BODY_FORCE_Z); -NODES[459].Fix(BODY_FORCE_X); -NODES[459].Fix(BODY_FORCE_Y); -NODES[459].Fix(BODY_FORCE_Z); -NODES[460].Fix(BODY_FORCE_X); -NODES[460].Fix(BODY_FORCE_Y); -NODES[460].Fix(BODY_FORCE_Z); -NODES[461].Fix(BODY_FORCE_X); -NODES[461].Fix(BODY_FORCE_Y); -NODES[461].Fix(BODY_FORCE_Z); -NODES[462].Fix(BODY_FORCE_X); -NODES[462].Fix(BODY_FORCE_Y); -NODES[462].Fix(BODY_FORCE_Z); -NODES[463].Fix(BODY_FORCE_X); -NODES[463].Fix(BODY_FORCE_Y); -NODES[463].Fix(BODY_FORCE_Z); -NODES[464].Fix(BODY_FORCE_X); -NODES[464].Fix(BODY_FORCE_Y); -NODES[464].Fix(BODY_FORCE_Z); -NODES[465].Fix(BODY_FORCE_X); -NODES[465].Fix(BODY_FORCE_Y); -NODES[465].Fix(BODY_FORCE_Z); -NODES[466].Fix(BODY_FORCE_X); -NODES[466].Fix(BODY_FORCE_Y); -NODES[466].Fix(BODY_FORCE_Z); -NODES[467].Fix(BODY_FORCE_X); -NODES[467].Fix(BODY_FORCE_Y); -NODES[467].Fix(BODY_FORCE_Z); -NODES[468].Fix(BODY_FORCE_X); -NODES[468].Fix(BODY_FORCE_Y); -NODES[468].Fix(BODY_FORCE_Z); -NODES[469].Fix(BODY_FORCE_X); -NODES[469].Fix(BODY_FORCE_Y); -NODES[469].Fix(BODY_FORCE_Z); -NODES[471].Fix(BODY_FORCE_X); -NODES[471].Fix(BODY_FORCE_Y); -NODES[471].Fix(BODY_FORCE_Z); -NODES[472].Fix(BODY_FORCE_X); -NODES[472].Fix(BODY_FORCE_Y); -NODES[472].Fix(BODY_FORCE_Z); -NODES[473].Fix(BODY_FORCE_X); -NODES[473].Fix(BODY_FORCE_Y); -NODES[473].Fix(BODY_FORCE_Z); -NODES[474].Fix(BODY_FORCE_X); -NODES[474].Fix(BODY_FORCE_Y); -NODES[474].Fix(BODY_FORCE_Z); -NODES[475].Fix(BODY_FORCE_X); -NODES[475].Fix(BODY_FORCE_Y); -NODES[475].Fix(BODY_FORCE_Z); -NODES[476].Fix(BODY_FORCE_X); -NODES[476].Fix(BODY_FORCE_Y); -NODES[476].Fix(BODY_FORCE_Z); -NODES[477].Fix(BODY_FORCE_X); -NODES[477].Fix(BODY_FORCE_Y); -NODES[477].Fix(BODY_FORCE_Z); -NODES[478].Fix(BODY_FORCE_X); -NODES[478].Fix(BODY_FORCE_Y); -NODES[478].Fix(BODY_FORCE_Z); -NODES[479].Fix(BODY_FORCE_X); -NODES[479].Fix(BODY_FORCE_Y); -NODES[479].Fix(BODY_FORCE_Z); -NODES[480].Fix(BODY_FORCE_X); -NODES[480].Fix(BODY_FORCE_Y); -NODES[480].Fix(BODY_FORCE_Z); -NODES[481].Fix(BODY_FORCE_X); -NODES[481].Fix(BODY_FORCE_Y); -NODES[481].Fix(BODY_FORCE_Z); -NODES[482].Fix(BODY_FORCE_X); -NODES[482].Fix(BODY_FORCE_Y); -NODES[482].Fix(BODY_FORCE_Z); -NODES[483].Fix(BODY_FORCE_X); -NODES[483].Fix(BODY_FORCE_Y); -NODES[483].Fix(BODY_FORCE_Z); -NODES[484].Fix(BODY_FORCE_X); -NODES[484].Fix(BODY_FORCE_Y); -NODES[484].Fix(BODY_FORCE_Z); -NODES[485].Fix(BODY_FORCE_X); -NODES[485].Fix(BODY_FORCE_Y); -NODES[485].Fix(BODY_FORCE_Z); -NODES[486].Fix(BODY_FORCE_X); -NODES[486].Fix(BODY_FORCE_Y); -NODES[486].Fix(BODY_FORCE_Z); -NODES[487].Fix(BODY_FORCE_X); -NODES[487].Fix(BODY_FORCE_Y); -NODES[487].Fix(BODY_FORCE_Z); -NODES[488].Fix(BODY_FORCE_X); -NODES[488].Fix(BODY_FORCE_Y); -NODES[488].Fix(BODY_FORCE_Z); -NODES[489].Fix(BODY_FORCE_X); -NODES[489].Fix(BODY_FORCE_Y); -NODES[489].Fix(BODY_FORCE_Z); -NODES[490].Fix(BODY_FORCE_X); -NODES[490].Fix(BODY_FORCE_Y); -NODES[490].Fix(BODY_FORCE_Z); -NODES[491].Fix(BODY_FORCE_X); -NODES[491].Fix(BODY_FORCE_Y); -NODES[491].Fix(BODY_FORCE_Z); -NODES[492].Fix(BODY_FORCE_X); -NODES[492].Fix(BODY_FORCE_Y); -NODES[492].Fix(BODY_FORCE_Z); -NODES[493].Fix(BODY_FORCE_X); -NODES[493].Fix(BODY_FORCE_Y); -NODES[493].Fix(BODY_FORCE_Z); -NODES[494].Fix(BODY_FORCE_X); -NODES[494].Fix(BODY_FORCE_Y); -NODES[494].Fix(BODY_FORCE_Z); -NODES[495].Fix(BODY_FORCE_X); -NODES[495].Fix(BODY_FORCE_Y); -NODES[495].Fix(BODY_FORCE_Z); -NODES[496].Fix(BODY_FORCE_X); -NODES[496].Fix(BODY_FORCE_Y); -NODES[496].Fix(BODY_FORCE_Z); -NODES[497].Fix(BODY_FORCE_X); -NODES[497].Fix(BODY_FORCE_Y); -NODES[497].Fix(BODY_FORCE_Z); -NODES[498].Fix(BODY_FORCE_X); -NODES[498].Fix(BODY_FORCE_Y); -NODES[498].Fix(BODY_FORCE_Z); -NODES[499].Fix(BODY_FORCE_X); -NODES[499].Fix(BODY_FORCE_Y); -NODES[499].Fix(BODY_FORCE_Z); -NODES[500].Fix(BODY_FORCE_X); -NODES[500].Fix(BODY_FORCE_Y); -NODES[500].Fix(BODY_FORCE_Z); -NODES[501].Fix(BODY_FORCE_X); -NODES[501].Fix(BODY_FORCE_Y); -NODES[501].Fix(BODY_FORCE_Z); -NODES[502].Fix(BODY_FORCE_X); -NODES[502].Fix(BODY_FORCE_Y); -NODES[502].Fix(BODY_FORCE_Z); -NODES[503].Fix(BODY_FORCE_X); -NODES[503].Fix(BODY_FORCE_Y); -NODES[503].Fix(BODY_FORCE_Z); -NODES[504].Fix(BODY_FORCE_X); -NODES[504].Fix(BODY_FORCE_Y); -NODES[504].Fix(BODY_FORCE_Z); -NODES[505].Fix(BODY_FORCE_X); -NODES[505].Fix(BODY_FORCE_Y); -NODES[505].Fix(BODY_FORCE_Z); -NODES[506].Fix(BODY_FORCE_X); -NODES[506].Fix(BODY_FORCE_Y); -NODES[506].Fix(BODY_FORCE_Z); -NODES[507].Fix(BODY_FORCE_X); -NODES[507].Fix(BODY_FORCE_Y); -NODES[507].Fix(BODY_FORCE_Z); -NODES[508].Fix(BODY_FORCE_X); -NODES[508].Fix(BODY_FORCE_Y); -NODES[508].Fix(BODY_FORCE_Z); -NODES[509].Fix(BODY_FORCE_X); -NODES[509].Fix(BODY_FORCE_Y); -NODES[509].Fix(BODY_FORCE_Z); -NODES[510].Fix(BODY_FORCE_X); -NODES[510].Fix(BODY_FORCE_Y); -NODES[510].Fix(BODY_FORCE_Z); -NODES[511].Fix(BODY_FORCE_X); -NODES[511].Fix(BODY_FORCE_Y); -NODES[511].Fix(BODY_FORCE_Z); -NODES[512].Fix(BODY_FORCE_X); -NODES[512].Fix(BODY_FORCE_Y); -NODES[512].Fix(BODY_FORCE_Z); -NODES[513].Fix(BODY_FORCE_X); -NODES[513].Fix(BODY_FORCE_Y); -NODES[513].Fix(BODY_FORCE_Z); -NODES[514].Fix(BODY_FORCE_X); -NODES[514].Fix(BODY_FORCE_Y); -NODES[514].Fix(BODY_FORCE_Z); -NODES[515].Fix(BODY_FORCE_X); -NODES[515].Fix(BODY_FORCE_Y); -NODES[515].Fix(BODY_FORCE_Z); -NODES[516].Fix(BODY_FORCE_X); -NODES[516].Fix(BODY_FORCE_Y); -NODES[516].Fix(BODY_FORCE_Z); -NODES[517].Fix(BODY_FORCE_X); -NODES[517].Fix(BODY_FORCE_Y); -NODES[517].Fix(BODY_FORCE_Z); -NODES[519].Fix(BODY_FORCE_X); -NODES[519].Fix(BODY_FORCE_Y); -NODES[519].Fix(BODY_FORCE_Z); -NODES[520].Fix(BODY_FORCE_X); -NODES[520].Fix(BODY_FORCE_Y); -NODES[520].Fix(BODY_FORCE_Z); -NODES[521].Fix(BODY_FORCE_X); -NODES[521].Fix(BODY_FORCE_Y); -NODES[521].Fix(BODY_FORCE_Z); -NODES[522].Fix(BODY_FORCE_X); -NODES[522].Fix(BODY_FORCE_Y); -NODES[522].Fix(BODY_FORCE_Z); -NODES[523].Fix(BODY_FORCE_X); -NODES[523].Fix(BODY_FORCE_Y); -NODES[523].Fix(BODY_FORCE_Z); -NODES[524].Fix(BODY_FORCE_X); -NODES[524].Fix(BODY_FORCE_Y); -NODES[524].Fix(BODY_FORCE_Z); -NODES[525].Fix(BODY_FORCE_X); -NODES[525].Fix(BODY_FORCE_Y); -NODES[525].Fix(BODY_FORCE_Z); -NODES[526].Fix(BODY_FORCE_X); -NODES[526].Fix(BODY_FORCE_Y); -NODES[526].Fix(BODY_FORCE_Z); -NODES[527].Fix(BODY_FORCE_X); -NODES[527].Fix(BODY_FORCE_Y); -NODES[527].Fix(BODY_FORCE_Z); -NODES[528].Fix(BODY_FORCE_X); -NODES[528].Fix(BODY_FORCE_Y); -NODES[528].Fix(BODY_FORCE_Z); -NODES[529].Fix(BODY_FORCE_X); -NODES[529].Fix(BODY_FORCE_Y); -NODES[529].Fix(BODY_FORCE_Z); -NODES[530].Fix(BODY_FORCE_X); -NODES[530].Fix(BODY_FORCE_Y); -NODES[530].Fix(BODY_FORCE_Z); -NODES[531].Fix(BODY_FORCE_X); -NODES[531].Fix(BODY_FORCE_Y); -NODES[531].Fix(BODY_FORCE_Z); -NODES[532].Fix(BODY_FORCE_X); -NODES[532].Fix(BODY_FORCE_Y); -NODES[532].Fix(BODY_FORCE_Z); -NODES[533].Fix(BODY_FORCE_X); -NODES[533].Fix(BODY_FORCE_Y); -NODES[533].Fix(BODY_FORCE_Z); -NODES[534].Fix(BODY_FORCE_X); -NODES[534].Fix(BODY_FORCE_Y); -NODES[534].Fix(BODY_FORCE_Z); -NODES[535].Fix(BODY_FORCE_X); -NODES[535].Fix(BODY_FORCE_Y); -NODES[535].Fix(BODY_FORCE_Z); -NODES[536].Fix(BODY_FORCE_X); -NODES[536].Fix(BODY_FORCE_Y); -NODES[536].Fix(BODY_FORCE_Z); -NODES[537].Fix(BODY_FORCE_X); -NODES[537].Fix(BODY_FORCE_Y); -NODES[537].Fix(BODY_FORCE_Z); -NODES[538].Fix(BODY_FORCE_X); -NODES[538].Fix(BODY_FORCE_Y); -NODES[538].Fix(BODY_FORCE_Z); -NODES[539].Fix(BODY_FORCE_X); -NODES[539].Fix(BODY_FORCE_Y); -NODES[539].Fix(BODY_FORCE_Z); -NODES[540].Fix(BODY_FORCE_X); -NODES[540].Fix(BODY_FORCE_Y); -NODES[540].Fix(BODY_FORCE_Z); -NODES[541].Fix(BODY_FORCE_X); -NODES[541].Fix(BODY_FORCE_Y); -NODES[541].Fix(BODY_FORCE_Z); -NODES[542].Fix(BODY_FORCE_X); -NODES[542].Fix(BODY_FORCE_Y); -NODES[542].Fix(BODY_FORCE_Z); -NODES[543].Fix(BODY_FORCE_X); -NODES[543].Fix(BODY_FORCE_Y); -NODES[543].Fix(BODY_FORCE_Z); -NODES[544].Fix(BODY_FORCE_X); -NODES[544].Fix(BODY_FORCE_Y); -NODES[544].Fix(BODY_FORCE_Z); -NODES[545].Fix(BODY_FORCE_X); -NODES[545].Fix(BODY_FORCE_Y); -NODES[545].Fix(BODY_FORCE_Z); -NODES[546].Fix(BODY_FORCE_X); -NODES[546].Fix(BODY_FORCE_Y); -NODES[546].Fix(BODY_FORCE_Z); -NODES[547].Fix(BODY_FORCE_X); -NODES[547].Fix(BODY_FORCE_Y); -NODES[547].Fix(BODY_FORCE_Z); -NODES[548].Fix(BODY_FORCE_X); -NODES[548].Fix(BODY_FORCE_Y); -NODES[548].Fix(BODY_FORCE_Z); -NODES[549].Fix(BODY_FORCE_X); -NODES[549].Fix(BODY_FORCE_Y); -NODES[549].Fix(BODY_FORCE_Z); -NODES[550].Fix(BODY_FORCE_X); -NODES[550].Fix(BODY_FORCE_Y); -NODES[550].Fix(BODY_FORCE_Z); -NODES[551].Fix(BODY_FORCE_X); -NODES[551].Fix(BODY_FORCE_Y); -NODES[551].Fix(BODY_FORCE_Z); -NODES[552].Fix(BODY_FORCE_X); -NODES[552].Fix(BODY_FORCE_Y); -NODES[552].Fix(BODY_FORCE_Z); -NODES[553].Fix(BODY_FORCE_X); -NODES[553].Fix(BODY_FORCE_Y); -NODES[553].Fix(BODY_FORCE_Z); -NODES[554].Fix(BODY_FORCE_X); -NODES[554].Fix(BODY_FORCE_Y); -NODES[554].Fix(BODY_FORCE_Z); -NODES[555].Fix(BODY_FORCE_X); -NODES[555].Fix(BODY_FORCE_Y); -NODES[555].Fix(BODY_FORCE_Z); -NODES[556].Fix(BODY_FORCE_X); -NODES[556].Fix(BODY_FORCE_Y); -NODES[556].Fix(BODY_FORCE_Z); -NODES[557].Fix(BODY_FORCE_X); -NODES[557].Fix(BODY_FORCE_Y); -NODES[557].Fix(BODY_FORCE_Z); -NODES[558].Fix(BODY_FORCE_X); -NODES[558].Fix(BODY_FORCE_Y); -NODES[558].Fix(BODY_FORCE_Z); -NODES[559].Fix(BODY_FORCE_X); -NODES[559].Fix(BODY_FORCE_Y); -NODES[559].Fix(BODY_FORCE_Z); -NODES[560].Fix(BODY_FORCE_X); -NODES[560].Fix(BODY_FORCE_Y); -NODES[560].Fix(BODY_FORCE_Z); -NODES[561].Fix(BODY_FORCE_X); -NODES[561].Fix(BODY_FORCE_Y); -NODES[561].Fix(BODY_FORCE_Z); -NODES[562].Fix(BODY_FORCE_X); -NODES[562].Fix(BODY_FORCE_Y); -NODES[562].Fix(BODY_FORCE_Z); -NODES[563].Fix(BODY_FORCE_X); -NODES[563].Fix(BODY_FORCE_Y); -NODES[563].Fix(BODY_FORCE_Z); -NODES[564].Fix(BODY_FORCE_X); -NODES[564].Fix(BODY_FORCE_Y); -NODES[564].Fix(BODY_FORCE_Z); -NODES[565].Fix(BODY_FORCE_X); -NODES[565].Fix(BODY_FORCE_Y); -NODES[565].Fix(BODY_FORCE_Z); -NODES[566].Fix(BODY_FORCE_X); -NODES[566].Fix(BODY_FORCE_Y); -NODES[566].Fix(BODY_FORCE_Z); -NODES[567].Fix(BODY_FORCE_X); -NODES[567].Fix(BODY_FORCE_Y); -NODES[567].Fix(BODY_FORCE_Z); -NODES[568].Fix(BODY_FORCE_X); -NODES[568].Fix(BODY_FORCE_Y); -NODES[568].Fix(BODY_FORCE_Z); -NODES[569].Fix(BODY_FORCE_X); -NODES[569].Fix(BODY_FORCE_Y); -NODES[569].Fix(BODY_FORCE_Z); -NODES[571].Fix(BODY_FORCE_X); -NODES[571].Fix(BODY_FORCE_Y); -NODES[571].Fix(BODY_FORCE_Z); -NODES[572].Fix(BODY_FORCE_X); -NODES[572].Fix(BODY_FORCE_Y); -NODES[572].Fix(BODY_FORCE_Z); -NODES[573].Fix(BODY_FORCE_X); -NODES[573].Fix(BODY_FORCE_Y); -NODES[573].Fix(BODY_FORCE_Z); -NODES[574].Fix(BODY_FORCE_X); -NODES[574].Fix(BODY_FORCE_Y); -NODES[574].Fix(BODY_FORCE_Z); -NODES[575].Fix(BODY_FORCE_X); -NODES[575].Fix(BODY_FORCE_Y); -NODES[575].Fix(BODY_FORCE_Z); -NODES[576].Fix(BODY_FORCE_X); -NODES[576].Fix(BODY_FORCE_Y); -NODES[576].Fix(BODY_FORCE_Z); -NODES[577].Fix(BODY_FORCE_X); -NODES[577].Fix(BODY_FORCE_Y); -NODES[577].Fix(BODY_FORCE_Z); -NODES[578].Fix(BODY_FORCE_X); -NODES[578].Fix(BODY_FORCE_Y); -NODES[578].Fix(BODY_FORCE_Z); -NODES[579].Fix(BODY_FORCE_X); -NODES[579].Fix(BODY_FORCE_Y); -NODES[579].Fix(BODY_FORCE_Z); -NODES[580].Fix(BODY_FORCE_X); -NODES[580].Fix(BODY_FORCE_Y); -NODES[580].Fix(BODY_FORCE_Z); -NODES[581].Fix(BODY_FORCE_X); -NODES[581].Fix(BODY_FORCE_Y); -NODES[581].Fix(BODY_FORCE_Z); -NODES[582].Fix(BODY_FORCE_X); -NODES[582].Fix(BODY_FORCE_Y); -NODES[582].Fix(BODY_FORCE_Z); -NODES[583].Fix(BODY_FORCE_X); -NODES[583].Fix(BODY_FORCE_Y); -NODES[583].Fix(BODY_FORCE_Z); -NODES[584].Fix(BODY_FORCE_X); -NODES[584].Fix(BODY_FORCE_Y); -NODES[584].Fix(BODY_FORCE_Z); -NODES[585].Fix(BODY_FORCE_X); -NODES[585].Fix(BODY_FORCE_Y); -NODES[585].Fix(BODY_FORCE_Z); -NODES[586].Fix(BODY_FORCE_X); -NODES[586].Fix(BODY_FORCE_Y); -NODES[586].Fix(BODY_FORCE_Z); -NODES[587].Fix(BODY_FORCE_X); -NODES[587].Fix(BODY_FORCE_Y); -NODES[587].Fix(BODY_FORCE_Z); -NODES[588].Fix(BODY_FORCE_X); -NODES[588].Fix(BODY_FORCE_Y); -NODES[588].Fix(BODY_FORCE_Z); -NODES[589].Fix(BODY_FORCE_X); -NODES[589].Fix(BODY_FORCE_Y); -NODES[589].Fix(BODY_FORCE_Z); -NODES[590].Fix(BODY_FORCE_X); -NODES[590].Fix(BODY_FORCE_Y); -NODES[590].Fix(BODY_FORCE_Z); -NODES[591].Fix(BODY_FORCE_X); -NODES[591].Fix(BODY_FORCE_Y); -NODES[591].Fix(BODY_FORCE_Z); -NODES[592].Fix(BODY_FORCE_X); -NODES[592].Fix(BODY_FORCE_Y); -NODES[592].Fix(BODY_FORCE_Z); -NODES[593].Fix(BODY_FORCE_X); -NODES[593].Fix(BODY_FORCE_Y); -NODES[593].Fix(BODY_FORCE_Z); -NODES[594].Fix(BODY_FORCE_X); -NODES[594].Fix(BODY_FORCE_Y); -NODES[594].Fix(BODY_FORCE_Z); -NODES[595].Fix(BODY_FORCE_X); -NODES[595].Fix(BODY_FORCE_Y); -NODES[595].Fix(BODY_FORCE_Z); -NODES[596].Fix(BODY_FORCE_X); -NODES[596].Fix(BODY_FORCE_Y); -NODES[596].Fix(BODY_FORCE_Z); -NODES[597].Fix(BODY_FORCE_X); -NODES[597].Fix(BODY_FORCE_Y); -NODES[597].Fix(BODY_FORCE_Z); -NODES[598].Fix(BODY_FORCE_X); -NODES[598].Fix(BODY_FORCE_Y); -NODES[598].Fix(BODY_FORCE_Z); -NODES[599].Fix(BODY_FORCE_X); -NODES[599].Fix(BODY_FORCE_Y); -NODES[599].Fix(BODY_FORCE_Z); -NODES[600].Fix(BODY_FORCE_X); -NODES[600].Fix(BODY_FORCE_Y); -NODES[600].Fix(BODY_FORCE_Z); -NODES[601].Fix(BODY_FORCE_X); -NODES[601].Fix(BODY_FORCE_Y); -NODES[601].Fix(BODY_FORCE_Z); -NODES[602].Fix(BODY_FORCE_X); -NODES[602].Fix(BODY_FORCE_Y); -NODES[602].Fix(BODY_FORCE_Z); -NODES[603].Fix(BODY_FORCE_X); -NODES[603].Fix(BODY_FORCE_Y); -NODES[603].Fix(BODY_FORCE_Z); -NODES[604].Fix(BODY_FORCE_X); -NODES[604].Fix(BODY_FORCE_Y); -NODES[604].Fix(BODY_FORCE_Z); -NODES[605].Fix(BODY_FORCE_X); -NODES[605].Fix(BODY_FORCE_Y); -NODES[605].Fix(BODY_FORCE_Z); -NODES[606].Fix(BODY_FORCE_X); -NODES[606].Fix(BODY_FORCE_Y); -NODES[606].Fix(BODY_FORCE_Z); -NODES[607].Fix(BODY_FORCE_X); -NODES[607].Fix(BODY_FORCE_Y); -NODES[607].Fix(BODY_FORCE_Z); -NODES[608].Fix(BODY_FORCE_X); -NODES[608].Fix(BODY_FORCE_Y); -NODES[608].Fix(BODY_FORCE_Z); -NODES[609].Fix(BODY_FORCE_X); -NODES[609].Fix(BODY_FORCE_Y); -NODES[609].Fix(BODY_FORCE_Z); -NODES[610].Fix(BODY_FORCE_X); -NODES[610].Fix(BODY_FORCE_Y); -NODES[610].Fix(BODY_FORCE_Z); -NODES[611].Fix(BODY_FORCE_X); -NODES[611].Fix(BODY_FORCE_Y); -NODES[611].Fix(BODY_FORCE_Z); -NODES[612].Fix(BODY_FORCE_X); -NODES[612].Fix(BODY_FORCE_Y); -NODES[612].Fix(BODY_FORCE_Z); -NODES[613].Fix(BODY_FORCE_X); -NODES[613].Fix(BODY_FORCE_Y); -NODES[613].Fix(BODY_FORCE_Z); -NODES[614].Fix(BODY_FORCE_X); -NODES[614].Fix(BODY_FORCE_Y); -NODES[614].Fix(BODY_FORCE_Z); -NODES[615].Fix(BODY_FORCE_X); -NODES[615].Fix(BODY_FORCE_Y); -NODES[615].Fix(BODY_FORCE_Z); -NODES[616].Fix(BODY_FORCE_X); -NODES[616].Fix(BODY_FORCE_Y); -NODES[616].Fix(BODY_FORCE_Z); -NODES[617].Fix(BODY_FORCE_X); -NODES[617].Fix(BODY_FORCE_Y); -NODES[617].Fix(BODY_FORCE_Z); -NODES[618].Fix(BODY_FORCE_X); -NODES[618].Fix(BODY_FORCE_Y); -NODES[618].Fix(BODY_FORCE_Z); -NODES[619].Fix(BODY_FORCE_X); -NODES[619].Fix(BODY_FORCE_Y); -NODES[619].Fix(BODY_FORCE_Z); -NODES[620].Fix(BODY_FORCE_X); -NODES[620].Fix(BODY_FORCE_Y); -NODES[620].Fix(BODY_FORCE_Z); -NODES[621].Fix(BODY_FORCE_X); -NODES[621].Fix(BODY_FORCE_Y); -NODES[621].Fix(BODY_FORCE_Z); -NODES[623].Fix(BODY_FORCE_X); -NODES[623].Fix(BODY_FORCE_Y); -NODES[623].Fix(BODY_FORCE_Z); -NODES[624].Fix(BODY_FORCE_X); -NODES[624].Fix(BODY_FORCE_Y); -NODES[624].Fix(BODY_FORCE_Z); -NODES[625].Fix(BODY_FORCE_X); -NODES[625].Fix(BODY_FORCE_Y); -NODES[625].Fix(BODY_FORCE_Z); -NODES[626].Fix(BODY_FORCE_X); -NODES[626].Fix(BODY_FORCE_Y); -NODES[626].Fix(BODY_FORCE_Z); -NODES[627].Fix(BODY_FORCE_X); -NODES[627].Fix(BODY_FORCE_Y); -NODES[627].Fix(BODY_FORCE_Z); -NODES[628].Fix(BODY_FORCE_X); -NODES[628].Fix(BODY_FORCE_Y); -NODES[628].Fix(BODY_FORCE_Z); -NODES[629].Fix(BODY_FORCE_X); -NODES[629].Fix(BODY_FORCE_Y); -NODES[629].Fix(BODY_FORCE_Z); -NODES[630].Fix(BODY_FORCE_X); -NODES[630].Fix(BODY_FORCE_Y); -NODES[630].Fix(BODY_FORCE_Z); -NODES[631].Fix(BODY_FORCE_X); -NODES[631].Fix(BODY_FORCE_Y); -NODES[631].Fix(BODY_FORCE_Z); -NODES[632].Fix(BODY_FORCE_X); -NODES[632].Fix(BODY_FORCE_Y); -NODES[632].Fix(BODY_FORCE_Z); -NODES[633].Fix(BODY_FORCE_X); -NODES[633].Fix(BODY_FORCE_Y); -NODES[633].Fix(BODY_FORCE_Z); -NODES[634].Fix(BODY_FORCE_X); -NODES[634].Fix(BODY_FORCE_Y); -NODES[634].Fix(BODY_FORCE_Z); -NODES[635].Fix(BODY_FORCE_X); -NODES[635].Fix(BODY_FORCE_Y); -NODES[635].Fix(BODY_FORCE_Z); -NODES[636].Fix(BODY_FORCE_X); -NODES[636].Fix(BODY_FORCE_Y); -NODES[636].Fix(BODY_FORCE_Z); -NODES[637].Fix(BODY_FORCE_X); -NODES[637].Fix(BODY_FORCE_Y); -NODES[637].Fix(BODY_FORCE_Z); -NODES[638].Fix(BODY_FORCE_X); -NODES[638].Fix(BODY_FORCE_Y); -NODES[638].Fix(BODY_FORCE_Z); -NODES[639].Fix(BODY_FORCE_X); -NODES[639].Fix(BODY_FORCE_Y); -NODES[639].Fix(BODY_FORCE_Z); -NODES[640].Fix(BODY_FORCE_X); -NODES[640].Fix(BODY_FORCE_Y); -NODES[640].Fix(BODY_FORCE_Z); -NODES[641].Fix(BODY_FORCE_X); -NODES[641].Fix(BODY_FORCE_Y); -NODES[641].Fix(BODY_FORCE_Z); -NODES[642].Fix(BODY_FORCE_X); -NODES[642].Fix(BODY_FORCE_Y); -NODES[642].Fix(BODY_FORCE_Z); -NODES[643].Fix(BODY_FORCE_X); -NODES[643].Fix(BODY_FORCE_Y); -NODES[643].Fix(BODY_FORCE_Z); -NODES[644].Fix(BODY_FORCE_X); -NODES[644].Fix(BODY_FORCE_Y); -NODES[644].Fix(BODY_FORCE_Z); -NODES[645].Fix(BODY_FORCE_X); -NODES[645].Fix(BODY_FORCE_Y); -NODES[645].Fix(BODY_FORCE_Z); -NODES[646].Fix(BODY_FORCE_X); -NODES[646].Fix(BODY_FORCE_Y); -NODES[646].Fix(BODY_FORCE_Z); -NODES[647].Fix(BODY_FORCE_X); -NODES[647].Fix(BODY_FORCE_Y); -NODES[647].Fix(BODY_FORCE_Z); -NODES[648].Fix(BODY_FORCE_X); -NODES[648].Fix(BODY_FORCE_Y); -NODES[648].Fix(BODY_FORCE_Z); -NODES[649].Fix(BODY_FORCE_X); -NODES[649].Fix(BODY_FORCE_Y); -NODES[649].Fix(BODY_FORCE_Z); -NODES[650].Fix(BODY_FORCE_X); -NODES[650].Fix(BODY_FORCE_Y); -NODES[650].Fix(BODY_FORCE_Z); -NODES[651].Fix(BODY_FORCE_X); -NODES[651].Fix(BODY_FORCE_Y); -NODES[651].Fix(BODY_FORCE_Z); -NODES[652].Fix(BODY_FORCE_X); -NODES[652].Fix(BODY_FORCE_Y); -NODES[652].Fix(BODY_FORCE_Z); -NODES[653].Fix(BODY_FORCE_X); -NODES[653].Fix(BODY_FORCE_Y); -NODES[653].Fix(BODY_FORCE_Z); -NODES[654].Fix(BODY_FORCE_X); -NODES[654].Fix(BODY_FORCE_Y); -NODES[654].Fix(BODY_FORCE_Z); -NODES[655].Fix(BODY_FORCE_X); -NODES[655].Fix(BODY_FORCE_Y); -NODES[655].Fix(BODY_FORCE_Z); -NODES[656].Fix(BODY_FORCE_X); -NODES[656].Fix(BODY_FORCE_Y); -NODES[656].Fix(BODY_FORCE_Z); -NODES[657].Fix(BODY_FORCE_X); -NODES[657].Fix(BODY_FORCE_Y); -NODES[657].Fix(BODY_FORCE_Z); -NODES[658].Fix(BODY_FORCE_X); -NODES[658].Fix(BODY_FORCE_Y); -NODES[658].Fix(BODY_FORCE_Z); -NODES[659].Fix(BODY_FORCE_X); -NODES[659].Fix(BODY_FORCE_Y); -NODES[659].Fix(BODY_FORCE_Z); -NODES[660].Fix(BODY_FORCE_X); -NODES[660].Fix(BODY_FORCE_Y); -NODES[660].Fix(BODY_FORCE_Z); -NODES[661].Fix(BODY_FORCE_X); -NODES[661].Fix(BODY_FORCE_Y); -NODES[661].Fix(BODY_FORCE_Z); -NODES[662].Fix(BODY_FORCE_X); -NODES[662].Fix(BODY_FORCE_Y); -NODES[662].Fix(BODY_FORCE_Z); -NODES[663].Fix(BODY_FORCE_X); -NODES[663].Fix(BODY_FORCE_Y); -NODES[663].Fix(BODY_FORCE_Z); -NODES[664].Fix(BODY_FORCE_X); -NODES[664].Fix(BODY_FORCE_Y); -NODES[664].Fix(BODY_FORCE_Z); -NODES[665].Fix(BODY_FORCE_X); -NODES[665].Fix(BODY_FORCE_Y); -NODES[665].Fix(BODY_FORCE_Z); -NODES[666].Fix(BODY_FORCE_X); -NODES[666].Fix(BODY_FORCE_Y); -NODES[666].Fix(BODY_FORCE_Z); -NODES[667].Fix(BODY_FORCE_X); -NODES[667].Fix(BODY_FORCE_Y); -NODES[667].Fix(BODY_FORCE_Z); -NODES[668].Fix(BODY_FORCE_X); -NODES[668].Fix(BODY_FORCE_Y); -NODES[668].Fix(BODY_FORCE_Z); -NODES[669].Fix(BODY_FORCE_X); -NODES[669].Fix(BODY_FORCE_Y); -NODES[669].Fix(BODY_FORCE_Z); -NODES[670].Fix(BODY_FORCE_X); -NODES[670].Fix(BODY_FORCE_Y); -NODES[670].Fix(BODY_FORCE_Z); -NODES[671].Fix(BODY_FORCE_X); -NODES[671].Fix(BODY_FORCE_Y); -NODES[671].Fix(BODY_FORCE_Z); -NODES[672].Fix(BODY_FORCE_X); -NODES[672].Fix(BODY_FORCE_Y); -NODES[672].Fix(BODY_FORCE_Z); -NODES[673].Fix(BODY_FORCE_X); -NODES[673].Fix(BODY_FORCE_Y); -NODES[673].Fix(BODY_FORCE_Z); -NODES[674].Fix(BODY_FORCE_X); -NODES[674].Fix(BODY_FORCE_Y); -NODES[674].Fix(BODY_FORCE_Z); -NODES[675].Fix(BODY_FORCE_X); -NODES[675].Fix(BODY_FORCE_Y); -NODES[675].Fix(BODY_FORCE_Z); -NODES[676].Fix(BODY_FORCE_X); -NODES[676].Fix(BODY_FORCE_Y); -NODES[676].Fix(BODY_FORCE_Z); -NODES[678].Fix(BODY_FORCE_X); -NODES[678].Fix(BODY_FORCE_Y); -NODES[678].Fix(BODY_FORCE_Z); -NODES[679].Fix(BODY_FORCE_X); -NODES[679].Fix(BODY_FORCE_Y); -NODES[679].Fix(BODY_FORCE_Z); -NODES[680].Fix(BODY_FORCE_X); -NODES[680].Fix(BODY_FORCE_Y); -NODES[680].Fix(BODY_FORCE_Z); -NODES[681].Fix(BODY_FORCE_X); -NODES[681].Fix(BODY_FORCE_Y); -NODES[681].Fix(BODY_FORCE_Z); -NODES[682].Fix(BODY_FORCE_X); -NODES[682].Fix(BODY_FORCE_Y); -NODES[682].Fix(BODY_FORCE_Z); -NODES[683].Fix(BODY_FORCE_X); -NODES[683].Fix(BODY_FORCE_Y); -NODES[683].Fix(BODY_FORCE_Z); -NODES[684].Fix(BODY_FORCE_X); -NODES[684].Fix(BODY_FORCE_Y); -NODES[684].Fix(BODY_FORCE_Z); -NODES[685].Fix(BODY_FORCE_X); -NODES[685].Fix(BODY_FORCE_Y); -NODES[685].Fix(BODY_FORCE_Z); -NODES[686].Fix(BODY_FORCE_X); -NODES[686].Fix(BODY_FORCE_Y); -NODES[686].Fix(BODY_FORCE_Z); -NODES[687].Fix(BODY_FORCE_X); -NODES[687].Fix(BODY_FORCE_Y); -NODES[687].Fix(BODY_FORCE_Z); -NODES[688].Fix(BODY_FORCE_X); -NODES[688].Fix(BODY_FORCE_Y); -NODES[688].Fix(BODY_FORCE_Z); -NODES[689].Fix(BODY_FORCE_X); -NODES[689].Fix(BODY_FORCE_Y); -NODES[689].Fix(BODY_FORCE_Z); -NODES[690].Fix(BODY_FORCE_X); -NODES[690].Fix(BODY_FORCE_Y); -NODES[690].Fix(BODY_FORCE_Z); -NODES[691].Fix(BODY_FORCE_X); -NODES[691].Fix(BODY_FORCE_Y); -NODES[691].Fix(BODY_FORCE_Z); -NODES[692].Fix(BODY_FORCE_X); -NODES[692].Fix(BODY_FORCE_Y); -NODES[692].Fix(BODY_FORCE_Z); -NODES[693].Fix(BODY_FORCE_X); -NODES[693].Fix(BODY_FORCE_Y); -NODES[693].Fix(BODY_FORCE_Z); -NODES[694].Fix(BODY_FORCE_X); -NODES[694].Fix(BODY_FORCE_Y); -NODES[694].Fix(BODY_FORCE_Z); -NODES[695].Fix(BODY_FORCE_X); -NODES[695].Fix(BODY_FORCE_Y); -NODES[695].Fix(BODY_FORCE_Z); -NODES[696].Fix(BODY_FORCE_X); -NODES[696].Fix(BODY_FORCE_Y); -NODES[696].Fix(BODY_FORCE_Z); -NODES[697].Fix(BODY_FORCE_X); -NODES[697].Fix(BODY_FORCE_Y); -NODES[697].Fix(BODY_FORCE_Z); -NODES[698].Fix(BODY_FORCE_X); -NODES[698].Fix(BODY_FORCE_Y); -NODES[698].Fix(BODY_FORCE_Z); -NODES[699].Fix(BODY_FORCE_X); -NODES[699].Fix(BODY_FORCE_Y); -NODES[699].Fix(BODY_FORCE_Z); -NODES[700].Fix(BODY_FORCE_X); -NODES[700].Fix(BODY_FORCE_Y); -NODES[700].Fix(BODY_FORCE_Z); -NODES[701].Fix(BODY_FORCE_X); -NODES[701].Fix(BODY_FORCE_Y); -NODES[701].Fix(BODY_FORCE_Z); -NODES[702].Fix(BODY_FORCE_X); -NODES[702].Fix(BODY_FORCE_Y); -NODES[702].Fix(BODY_FORCE_Z); -NODES[703].Fix(BODY_FORCE_X); -NODES[703].Fix(BODY_FORCE_Y); -NODES[703].Fix(BODY_FORCE_Z); -NODES[704].Fix(BODY_FORCE_X); -NODES[704].Fix(BODY_FORCE_Y); -NODES[704].Fix(BODY_FORCE_Z); -NODES[705].Fix(BODY_FORCE_X); -NODES[705].Fix(BODY_FORCE_Y); -NODES[705].Fix(BODY_FORCE_Z); -NODES[706].Fix(BODY_FORCE_X); -NODES[706].Fix(BODY_FORCE_Y); -NODES[706].Fix(BODY_FORCE_Z); -NODES[707].Fix(BODY_FORCE_X); -NODES[707].Fix(BODY_FORCE_Y); -NODES[707].Fix(BODY_FORCE_Z); -NODES[708].Fix(BODY_FORCE_X); -NODES[708].Fix(BODY_FORCE_Y); -NODES[708].Fix(BODY_FORCE_Z); -NODES[709].Fix(BODY_FORCE_X); -NODES[709].Fix(BODY_FORCE_Y); -NODES[709].Fix(BODY_FORCE_Z); -NODES[710].Fix(BODY_FORCE_X); -NODES[710].Fix(BODY_FORCE_Y); -NODES[710].Fix(BODY_FORCE_Z); -NODES[711].Fix(BODY_FORCE_X); -NODES[711].Fix(BODY_FORCE_Y); -NODES[711].Fix(BODY_FORCE_Z); -NODES[712].Fix(BODY_FORCE_X); -NODES[712].Fix(BODY_FORCE_Y); -NODES[712].Fix(BODY_FORCE_Z); -NODES[713].Fix(BODY_FORCE_X); -NODES[713].Fix(BODY_FORCE_Y); -NODES[713].Fix(BODY_FORCE_Z); -NODES[714].Fix(BODY_FORCE_X); -NODES[714].Fix(BODY_FORCE_Y); -NODES[714].Fix(BODY_FORCE_Z); -NODES[715].Fix(BODY_FORCE_X); -NODES[715].Fix(BODY_FORCE_Y); -NODES[715].Fix(BODY_FORCE_Z); -NODES[716].Fix(BODY_FORCE_X); -NODES[716].Fix(BODY_FORCE_Y); -NODES[716].Fix(BODY_FORCE_Z); -NODES[717].Fix(BODY_FORCE_X); -NODES[717].Fix(BODY_FORCE_Y); -NODES[717].Fix(BODY_FORCE_Z); -NODES[718].Fix(BODY_FORCE_X); -NODES[718].Fix(BODY_FORCE_Y); -NODES[718].Fix(BODY_FORCE_Z); -NODES[719].Fix(BODY_FORCE_X); -NODES[719].Fix(BODY_FORCE_Y); -NODES[719].Fix(BODY_FORCE_Z); -NODES[720].Fix(BODY_FORCE_X); -NODES[720].Fix(BODY_FORCE_Y); -NODES[720].Fix(BODY_FORCE_Z); -NODES[721].Fix(BODY_FORCE_X); -NODES[721].Fix(BODY_FORCE_Y); -NODES[721].Fix(BODY_FORCE_Z); -NODES[722].Fix(BODY_FORCE_X); -NODES[722].Fix(BODY_FORCE_Y); -NODES[722].Fix(BODY_FORCE_Z); -NODES[723].Fix(BODY_FORCE_X); -NODES[723].Fix(BODY_FORCE_Y); -NODES[723].Fix(BODY_FORCE_Z); -NODES[724].Fix(BODY_FORCE_X); -NODES[724].Fix(BODY_FORCE_Y); -NODES[724].Fix(BODY_FORCE_Z); -NODES[725].Fix(BODY_FORCE_X); -NODES[725].Fix(BODY_FORCE_Y); -NODES[725].Fix(BODY_FORCE_Z); -NODES[726].Fix(BODY_FORCE_X); -NODES[726].Fix(BODY_FORCE_Y); -NODES[726].Fix(BODY_FORCE_Z); -NODES[727].Fix(BODY_FORCE_X); -NODES[727].Fix(BODY_FORCE_Y); -NODES[727].Fix(BODY_FORCE_Z); -NODES[728].Fix(BODY_FORCE_X); -NODES[728].Fix(BODY_FORCE_Y); -NODES[728].Fix(BODY_FORCE_Z); -NODES[729].Fix(BODY_FORCE_X); -NODES[729].Fix(BODY_FORCE_Y); -NODES[729].Fix(BODY_FORCE_Z); -NODES[730].Fix(BODY_FORCE_X); -NODES[730].Fix(BODY_FORCE_Y); -NODES[730].Fix(BODY_FORCE_Z); -NODES[731].Fix(BODY_FORCE_X); -NODES[731].Fix(BODY_FORCE_Y); -NODES[731].Fix(BODY_FORCE_Z); -NODES[732].Fix(BODY_FORCE_X); -NODES[732].Fix(BODY_FORCE_Y); -NODES[732].Fix(BODY_FORCE_Z); -NODES[733].Fix(BODY_FORCE_X); -NODES[733].Fix(BODY_FORCE_Y); -NODES[733].Fix(BODY_FORCE_Z); -NODES[734].Fix(BODY_FORCE_X); -NODES[734].Fix(BODY_FORCE_Y); -NODES[734].Fix(BODY_FORCE_Z); -NODES[735].Fix(BODY_FORCE_X); -NODES[735].Fix(BODY_FORCE_Y); -NODES[735].Fix(BODY_FORCE_Z); -NODES[736].Fix(BODY_FORCE_X); -NODES[736].Fix(BODY_FORCE_Y); -NODES[736].Fix(BODY_FORCE_Z); -NODES[737].Fix(BODY_FORCE_X); -NODES[737].Fix(BODY_FORCE_Y); -NODES[737].Fix(BODY_FORCE_Z); -NODES[739].Fix(BODY_FORCE_X); -NODES[739].Fix(BODY_FORCE_Y); -NODES[739].Fix(BODY_FORCE_Z); -NODES[740].Fix(BODY_FORCE_X); -NODES[740].Fix(BODY_FORCE_Y); -NODES[740].Fix(BODY_FORCE_Z); -NODES[741].Fix(BODY_FORCE_X); -NODES[741].Fix(BODY_FORCE_Y); -NODES[741].Fix(BODY_FORCE_Z); -NODES[742].Fix(BODY_FORCE_X); -NODES[742].Fix(BODY_FORCE_Y); -NODES[742].Fix(BODY_FORCE_Z); -NODES[743].Fix(BODY_FORCE_X); -NODES[743].Fix(BODY_FORCE_Y); -NODES[743].Fix(BODY_FORCE_Z); -NODES[744].Fix(BODY_FORCE_X); -NODES[744].Fix(BODY_FORCE_Y); -NODES[744].Fix(BODY_FORCE_Z); -NODES[745].Fix(BODY_FORCE_X); -NODES[745].Fix(BODY_FORCE_Y); -NODES[745].Fix(BODY_FORCE_Z); -NODES[746].Fix(BODY_FORCE_X); -NODES[746].Fix(BODY_FORCE_Y); -NODES[746].Fix(BODY_FORCE_Z); -NODES[747].Fix(BODY_FORCE_X); -NODES[747].Fix(BODY_FORCE_Y); -NODES[747].Fix(BODY_FORCE_Z); -NODES[748].Fix(BODY_FORCE_X); -NODES[748].Fix(BODY_FORCE_Y); -NODES[748].Fix(BODY_FORCE_Z); -NODES[749].Fix(BODY_FORCE_X); -NODES[749].Fix(BODY_FORCE_Y); -NODES[749].Fix(BODY_FORCE_Z); -NODES[750].Fix(BODY_FORCE_X); -NODES[750].Fix(BODY_FORCE_Y); -NODES[750].Fix(BODY_FORCE_Z); -NODES[751].Fix(BODY_FORCE_X); -NODES[751].Fix(BODY_FORCE_Y); -NODES[751].Fix(BODY_FORCE_Z); -NODES[752].Fix(BODY_FORCE_X); -NODES[752].Fix(BODY_FORCE_Y); -NODES[752].Fix(BODY_FORCE_Z); -NODES[753].Fix(BODY_FORCE_X); -NODES[753].Fix(BODY_FORCE_Y); -NODES[753].Fix(BODY_FORCE_Z); -NODES[754].Fix(BODY_FORCE_X); -NODES[754].Fix(BODY_FORCE_Y); -NODES[754].Fix(BODY_FORCE_Z); -NODES[755].Fix(BODY_FORCE_X); -NODES[755].Fix(BODY_FORCE_Y); -NODES[755].Fix(BODY_FORCE_Z); -NODES[756].Fix(BODY_FORCE_X); -NODES[756].Fix(BODY_FORCE_Y); -NODES[756].Fix(BODY_FORCE_Z); -NODES[757].Fix(BODY_FORCE_X); -NODES[757].Fix(BODY_FORCE_Y); -NODES[757].Fix(BODY_FORCE_Z); -NODES[758].Fix(BODY_FORCE_X); -NODES[758].Fix(BODY_FORCE_Y); -NODES[758].Fix(BODY_FORCE_Z); -NODES[759].Fix(BODY_FORCE_X); -NODES[759].Fix(BODY_FORCE_Y); -NODES[759].Fix(BODY_FORCE_Z); -NODES[760].Fix(BODY_FORCE_X); -NODES[760].Fix(BODY_FORCE_Y); -NODES[760].Fix(BODY_FORCE_Z); -NODES[761].Fix(BODY_FORCE_X); -NODES[761].Fix(BODY_FORCE_Y); -NODES[761].Fix(BODY_FORCE_Z); -NODES[762].Fix(BODY_FORCE_X); -NODES[762].Fix(BODY_FORCE_Y); -NODES[762].Fix(BODY_FORCE_Z); -NODES[763].Fix(BODY_FORCE_X); -NODES[763].Fix(BODY_FORCE_Y); -NODES[763].Fix(BODY_FORCE_Z); -NODES[764].Fix(BODY_FORCE_X); -NODES[764].Fix(BODY_FORCE_Y); -NODES[764].Fix(BODY_FORCE_Z); -NODES[765].Fix(BODY_FORCE_X); -NODES[765].Fix(BODY_FORCE_Y); -NODES[765].Fix(BODY_FORCE_Z); -NODES[766].Fix(BODY_FORCE_X); -NODES[766].Fix(BODY_FORCE_Y); -NODES[766].Fix(BODY_FORCE_Z); -NODES[767].Fix(BODY_FORCE_X); -NODES[767].Fix(BODY_FORCE_Y); -NODES[767].Fix(BODY_FORCE_Z); -NODES[768].Fix(BODY_FORCE_X); -NODES[768].Fix(BODY_FORCE_Y); -NODES[768].Fix(BODY_FORCE_Z); -NODES[769].Fix(BODY_FORCE_X); -NODES[769].Fix(BODY_FORCE_Y); -NODES[769].Fix(BODY_FORCE_Z); -NODES[770].Fix(BODY_FORCE_X); -NODES[770].Fix(BODY_FORCE_Y); -NODES[770].Fix(BODY_FORCE_Z); -NODES[771].Fix(BODY_FORCE_X); -NODES[771].Fix(BODY_FORCE_Y); -NODES[771].Fix(BODY_FORCE_Z); -NODES[772].Fix(BODY_FORCE_X); -NODES[772].Fix(BODY_FORCE_Y); -NODES[772].Fix(BODY_FORCE_Z); -NODES[773].Fix(BODY_FORCE_X); -NODES[773].Fix(BODY_FORCE_Y); -NODES[773].Fix(BODY_FORCE_Z); -NODES[774].Fix(BODY_FORCE_X); -NODES[774].Fix(BODY_FORCE_Y); -NODES[774].Fix(BODY_FORCE_Z); -NODES[775].Fix(BODY_FORCE_X); -NODES[775].Fix(BODY_FORCE_Y); -NODES[775].Fix(BODY_FORCE_Z); -NODES[776].Fix(BODY_FORCE_X); -NODES[776].Fix(BODY_FORCE_Y); -NODES[776].Fix(BODY_FORCE_Z); -NODES[777].Fix(BODY_FORCE_X); -NODES[777].Fix(BODY_FORCE_Y); -NODES[777].Fix(BODY_FORCE_Z); -NODES[778].Fix(BODY_FORCE_X); -NODES[778].Fix(BODY_FORCE_Y); -NODES[778].Fix(BODY_FORCE_Z); -NODES[779].Fix(BODY_FORCE_X); -NODES[779].Fix(BODY_FORCE_Y); -NODES[779].Fix(BODY_FORCE_Z); -NODES[780].Fix(BODY_FORCE_X); -NODES[780].Fix(BODY_FORCE_Y); -NODES[780].Fix(BODY_FORCE_Z); -NODES[781].Fix(BODY_FORCE_X); -NODES[781].Fix(BODY_FORCE_Y); -NODES[781].Fix(BODY_FORCE_Z); -NODES[782].Fix(BODY_FORCE_X); -NODES[782].Fix(BODY_FORCE_Y); -NODES[782].Fix(BODY_FORCE_Z); -NODES[783].Fix(BODY_FORCE_X); -NODES[783].Fix(BODY_FORCE_Y); -NODES[783].Fix(BODY_FORCE_Z); -NODES[784].Fix(BODY_FORCE_X); -NODES[784].Fix(BODY_FORCE_Y); -NODES[784].Fix(BODY_FORCE_Z); -NODES[785].Fix(BODY_FORCE_X); -NODES[785].Fix(BODY_FORCE_Y); -NODES[785].Fix(BODY_FORCE_Z); -NODES[786].Fix(BODY_FORCE_X); -NODES[786].Fix(BODY_FORCE_Y); -NODES[786].Fix(BODY_FORCE_Z); -NODES[787].Fix(BODY_FORCE_X); -NODES[787].Fix(BODY_FORCE_Y); -NODES[787].Fix(BODY_FORCE_Z); -NODES[788].Fix(BODY_FORCE_X); -NODES[788].Fix(BODY_FORCE_Y); -NODES[788].Fix(BODY_FORCE_Z); -NODES[789].Fix(BODY_FORCE_X); -NODES[789].Fix(BODY_FORCE_Y); -NODES[789].Fix(BODY_FORCE_Z); -NODES[790].Fix(BODY_FORCE_X); -NODES[790].Fix(BODY_FORCE_Y); -NODES[790].Fix(BODY_FORCE_Z); -NODES[791].Fix(BODY_FORCE_X); -NODES[791].Fix(BODY_FORCE_Y); -NODES[791].Fix(BODY_FORCE_Z); -NODES[792].Fix(BODY_FORCE_X); -NODES[792].Fix(BODY_FORCE_Y); -NODES[792].Fix(BODY_FORCE_Z); -NODES[793].Fix(BODY_FORCE_X); -NODES[793].Fix(BODY_FORCE_Y); -NODES[793].Fix(BODY_FORCE_Z); -NODES[794].Fix(BODY_FORCE_X); -NODES[794].Fix(BODY_FORCE_Y); -NODES[794].Fix(BODY_FORCE_Z); -NODES[795].Fix(BODY_FORCE_X); -NODES[795].Fix(BODY_FORCE_Y); -NODES[795].Fix(BODY_FORCE_Z); -NODES[796].Fix(BODY_FORCE_X); -NODES[796].Fix(BODY_FORCE_Y); -NODES[796].Fix(BODY_FORCE_Z); -NODES[797].Fix(BODY_FORCE_X); -NODES[797].Fix(BODY_FORCE_Y); -NODES[797].Fix(BODY_FORCE_Z); -NODES[798].Fix(BODY_FORCE_X); -NODES[798].Fix(BODY_FORCE_Y); -NODES[798].Fix(BODY_FORCE_Z); -NODES[799].Fix(BODY_FORCE_X); -NODES[799].Fix(BODY_FORCE_Y); -NODES[799].Fix(BODY_FORCE_Z); -NODES[800].Fix(BODY_FORCE_X); -NODES[800].Fix(BODY_FORCE_Y); -NODES[800].Fix(BODY_FORCE_Z); -NODES[801].Fix(BODY_FORCE_X); -NODES[801].Fix(BODY_FORCE_Y); -NODES[801].Fix(BODY_FORCE_Z); -NODES[803].Fix(BODY_FORCE_X); -NODES[803].Fix(BODY_FORCE_Y); -NODES[803].Fix(BODY_FORCE_Z); -NODES[804].Fix(BODY_FORCE_X); -NODES[804].Fix(BODY_FORCE_Y); -NODES[804].Fix(BODY_FORCE_Z); -NODES[805].Fix(BODY_FORCE_X); -NODES[805].Fix(BODY_FORCE_Y); -NODES[805].Fix(BODY_FORCE_Z); -NODES[806].Fix(BODY_FORCE_X); -NODES[806].Fix(BODY_FORCE_Y); -NODES[806].Fix(BODY_FORCE_Z); -NODES[807].Fix(BODY_FORCE_X); -NODES[807].Fix(BODY_FORCE_Y); -NODES[807].Fix(BODY_FORCE_Z); -NODES[808].Fix(BODY_FORCE_X); -NODES[808].Fix(BODY_FORCE_Y); -NODES[808].Fix(BODY_FORCE_Z); -NODES[809].Fix(BODY_FORCE_X); -NODES[809].Fix(BODY_FORCE_Y); -NODES[809].Fix(BODY_FORCE_Z); -NODES[810].Fix(BODY_FORCE_X); -NODES[810].Fix(BODY_FORCE_Y); -NODES[810].Fix(BODY_FORCE_Z); -NODES[811].Fix(BODY_FORCE_X); -NODES[811].Fix(BODY_FORCE_Y); -NODES[811].Fix(BODY_FORCE_Z); -NODES[812].Fix(BODY_FORCE_X); -NODES[812].Fix(BODY_FORCE_Y); -NODES[812].Fix(BODY_FORCE_Z); -NODES[813].Fix(BODY_FORCE_X); -NODES[813].Fix(BODY_FORCE_Y); -NODES[813].Fix(BODY_FORCE_Z); -NODES[814].Fix(BODY_FORCE_X); -NODES[814].Fix(BODY_FORCE_Y); -NODES[814].Fix(BODY_FORCE_Z); -NODES[815].Fix(BODY_FORCE_X); -NODES[815].Fix(BODY_FORCE_Y); -NODES[815].Fix(BODY_FORCE_Z); -NODES[816].Fix(BODY_FORCE_X); -NODES[816].Fix(BODY_FORCE_Y); -NODES[816].Fix(BODY_FORCE_Z); -NODES[817].Fix(BODY_FORCE_X); -NODES[817].Fix(BODY_FORCE_Y); -NODES[817].Fix(BODY_FORCE_Z); -NODES[818].Fix(BODY_FORCE_X); -NODES[818].Fix(BODY_FORCE_Y); -NODES[818].Fix(BODY_FORCE_Z); -NODES[819].Fix(BODY_FORCE_X); -NODES[819].Fix(BODY_FORCE_Y); -NODES[819].Fix(BODY_FORCE_Z); -NODES[820].Fix(BODY_FORCE_X); -NODES[820].Fix(BODY_FORCE_Y); -NODES[820].Fix(BODY_FORCE_Z); -NODES[821].Fix(BODY_FORCE_X); -NODES[821].Fix(BODY_FORCE_Y); -NODES[821].Fix(BODY_FORCE_Z); -NODES[822].Fix(BODY_FORCE_X); -NODES[822].Fix(BODY_FORCE_Y); -NODES[822].Fix(BODY_FORCE_Z); -NODES[823].Fix(BODY_FORCE_X); -NODES[823].Fix(BODY_FORCE_Y); -NODES[823].Fix(BODY_FORCE_Z); -NODES[824].Fix(BODY_FORCE_X); -NODES[824].Fix(BODY_FORCE_Y); -NODES[824].Fix(BODY_FORCE_Z); -NODES[825].Fix(BODY_FORCE_X); -NODES[825].Fix(BODY_FORCE_Y); -NODES[825].Fix(BODY_FORCE_Z); -NODES[826].Fix(BODY_FORCE_X); -NODES[826].Fix(BODY_FORCE_Y); -NODES[826].Fix(BODY_FORCE_Z); -NODES[827].Fix(BODY_FORCE_X); -NODES[827].Fix(BODY_FORCE_Y); -NODES[827].Fix(BODY_FORCE_Z); -NODES[828].Fix(BODY_FORCE_X); -NODES[828].Fix(BODY_FORCE_Y); -NODES[828].Fix(BODY_FORCE_Z); -NODES[829].Fix(BODY_FORCE_X); -NODES[829].Fix(BODY_FORCE_Y); -NODES[829].Fix(BODY_FORCE_Z); -NODES[830].Fix(BODY_FORCE_X); -NODES[830].Fix(BODY_FORCE_Y); -NODES[830].Fix(BODY_FORCE_Z); -NODES[831].Fix(BODY_FORCE_X); -NODES[831].Fix(BODY_FORCE_Y); -NODES[831].Fix(BODY_FORCE_Z); -NODES[832].Fix(BODY_FORCE_X); -NODES[832].Fix(BODY_FORCE_Y); -NODES[832].Fix(BODY_FORCE_Z); -NODES[833].Fix(BODY_FORCE_X); -NODES[833].Fix(BODY_FORCE_Y); -NODES[833].Fix(BODY_FORCE_Z); -NODES[834].Fix(BODY_FORCE_X); -NODES[834].Fix(BODY_FORCE_Y); -NODES[834].Fix(BODY_FORCE_Z); -NODES[835].Fix(BODY_FORCE_X); -NODES[835].Fix(BODY_FORCE_Y); -NODES[835].Fix(BODY_FORCE_Z); -NODES[836].Fix(BODY_FORCE_X); -NODES[836].Fix(BODY_FORCE_Y); -NODES[836].Fix(BODY_FORCE_Z); -NODES[837].Fix(BODY_FORCE_X); -NODES[837].Fix(BODY_FORCE_Y); -NODES[837].Fix(BODY_FORCE_Z); -NODES[838].Fix(BODY_FORCE_X); -NODES[838].Fix(BODY_FORCE_Y); -NODES[838].Fix(BODY_FORCE_Z); -NODES[839].Fix(BODY_FORCE_X); -NODES[839].Fix(BODY_FORCE_Y); -NODES[839].Fix(BODY_FORCE_Z); -NODES[840].Fix(BODY_FORCE_X); -NODES[840].Fix(BODY_FORCE_Y); -NODES[840].Fix(BODY_FORCE_Z); -NODES[841].Fix(BODY_FORCE_X); -NODES[841].Fix(BODY_FORCE_Y); -NODES[841].Fix(BODY_FORCE_Z); -NODES[842].Fix(BODY_FORCE_X); -NODES[842].Fix(BODY_FORCE_Y); -NODES[842].Fix(BODY_FORCE_Z); -NODES[843].Fix(BODY_FORCE_X); -NODES[843].Fix(BODY_FORCE_Y); -NODES[843].Fix(BODY_FORCE_Z); -NODES[844].Fix(BODY_FORCE_X); -NODES[844].Fix(BODY_FORCE_Y); -NODES[844].Fix(BODY_FORCE_Z); -NODES[845].Fix(BODY_FORCE_X); -NODES[845].Fix(BODY_FORCE_Y); -NODES[845].Fix(BODY_FORCE_Z); -NODES[846].Fix(BODY_FORCE_X); -NODES[846].Fix(BODY_FORCE_Y); -NODES[846].Fix(BODY_FORCE_Z); -NODES[847].Fix(BODY_FORCE_X); -NODES[847].Fix(BODY_FORCE_Y); -NODES[847].Fix(BODY_FORCE_Z); -NODES[848].Fix(BODY_FORCE_X); -NODES[848].Fix(BODY_FORCE_Y); -NODES[848].Fix(BODY_FORCE_Z); -NODES[849].Fix(BODY_FORCE_X); -NODES[849].Fix(BODY_FORCE_Y); -NODES[849].Fix(BODY_FORCE_Z); -NODES[850].Fix(BODY_FORCE_X); -NODES[850].Fix(BODY_FORCE_Y); -NODES[850].Fix(BODY_FORCE_Z); -NODES[851].Fix(BODY_FORCE_X); -NODES[851].Fix(BODY_FORCE_Y); -NODES[851].Fix(BODY_FORCE_Z); -NODES[852].Fix(BODY_FORCE_X); -NODES[852].Fix(BODY_FORCE_Y); -NODES[852].Fix(BODY_FORCE_Z); -NODES[853].Fix(BODY_FORCE_X); -NODES[853].Fix(BODY_FORCE_Y); -NODES[853].Fix(BODY_FORCE_Z); -NODES[854].Fix(BODY_FORCE_X); -NODES[854].Fix(BODY_FORCE_Y); -NODES[854].Fix(BODY_FORCE_Z); -NODES[855].Fix(BODY_FORCE_X); -NODES[855].Fix(BODY_FORCE_Y); -NODES[855].Fix(BODY_FORCE_Z); -NODES[856].Fix(BODY_FORCE_X); -NODES[856].Fix(BODY_FORCE_Y); -NODES[856].Fix(BODY_FORCE_Z); -NODES[857].Fix(BODY_FORCE_X); -NODES[857].Fix(BODY_FORCE_Y); -NODES[857].Fix(BODY_FORCE_Z); -NODES[858].Fix(BODY_FORCE_X); -NODES[858].Fix(BODY_FORCE_Y); -NODES[858].Fix(BODY_FORCE_Z); -NODES[859].Fix(BODY_FORCE_X); -NODES[859].Fix(BODY_FORCE_Y); -NODES[859].Fix(BODY_FORCE_Z); -NODES[860].Fix(BODY_FORCE_X); -NODES[860].Fix(BODY_FORCE_Y); -NODES[860].Fix(BODY_FORCE_Z); -NODES[861].Fix(BODY_FORCE_X); -NODES[861].Fix(BODY_FORCE_Y); -NODES[861].Fix(BODY_FORCE_Z); -NODES[862].Fix(BODY_FORCE_X); -NODES[862].Fix(BODY_FORCE_Y); -NODES[862].Fix(BODY_FORCE_Z); -NODES[863].Fix(BODY_FORCE_X); -NODES[863].Fix(BODY_FORCE_Y); -NODES[863].Fix(BODY_FORCE_Z); -NODES[864].Fix(BODY_FORCE_X); -NODES[864].Fix(BODY_FORCE_Y); -NODES[864].Fix(BODY_FORCE_Z); -NODES[865].Fix(BODY_FORCE_X); -NODES[865].Fix(BODY_FORCE_Y); -NODES[865].Fix(BODY_FORCE_Z); -NODES[866].Fix(BODY_FORCE_X); -NODES[866].Fix(BODY_FORCE_Y); -NODES[866].Fix(BODY_FORCE_Z); -NODES[868].Fix(BODY_FORCE_X); -NODES[868].Fix(BODY_FORCE_Y); -NODES[868].Fix(BODY_FORCE_Z); -NODES[869].Fix(BODY_FORCE_X); -NODES[869].Fix(BODY_FORCE_Y); -NODES[869].Fix(BODY_FORCE_Z); -NODES[870].Fix(BODY_FORCE_X); -NODES[870].Fix(BODY_FORCE_Y); -NODES[870].Fix(BODY_FORCE_Z); -NODES[871].Fix(BODY_FORCE_X); -NODES[871].Fix(BODY_FORCE_Y); -NODES[871].Fix(BODY_FORCE_Z); -NODES[872].Fix(BODY_FORCE_X); -NODES[872].Fix(BODY_FORCE_Y); -NODES[872].Fix(BODY_FORCE_Z); -NODES[873].Fix(BODY_FORCE_X); -NODES[873].Fix(BODY_FORCE_Y); -NODES[873].Fix(BODY_FORCE_Z); -NODES[874].Fix(BODY_FORCE_X); -NODES[874].Fix(BODY_FORCE_Y); -NODES[874].Fix(BODY_FORCE_Z); -NODES[875].Fix(BODY_FORCE_X); -NODES[875].Fix(BODY_FORCE_Y); -NODES[875].Fix(BODY_FORCE_Z); -NODES[876].Fix(BODY_FORCE_X); -NODES[876].Fix(BODY_FORCE_Y); -NODES[876].Fix(BODY_FORCE_Z); -NODES[877].Fix(BODY_FORCE_X); -NODES[877].Fix(BODY_FORCE_Y); -NODES[877].Fix(BODY_FORCE_Z); -NODES[878].Fix(BODY_FORCE_X); -NODES[878].Fix(BODY_FORCE_Y); -NODES[878].Fix(BODY_FORCE_Z); -NODES[879].Fix(BODY_FORCE_X); -NODES[879].Fix(BODY_FORCE_Y); -NODES[879].Fix(BODY_FORCE_Z); -NODES[880].Fix(BODY_FORCE_X); -NODES[880].Fix(BODY_FORCE_Y); -NODES[880].Fix(BODY_FORCE_Z); -NODES[881].Fix(BODY_FORCE_X); -NODES[881].Fix(BODY_FORCE_Y); -NODES[881].Fix(BODY_FORCE_Z); -NODES[882].Fix(BODY_FORCE_X); -NODES[882].Fix(BODY_FORCE_Y); -NODES[882].Fix(BODY_FORCE_Z); -NODES[883].Fix(BODY_FORCE_X); -NODES[883].Fix(BODY_FORCE_Y); -NODES[883].Fix(BODY_FORCE_Z); -NODES[884].Fix(BODY_FORCE_X); -NODES[884].Fix(BODY_FORCE_Y); -NODES[884].Fix(BODY_FORCE_Z); -NODES[885].Fix(BODY_FORCE_X); -NODES[885].Fix(BODY_FORCE_Y); -NODES[885].Fix(BODY_FORCE_Z); -NODES[886].Fix(BODY_FORCE_X); -NODES[886].Fix(BODY_FORCE_Y); -NODES[886].Fix(BODY_FORCE_Z); -NODES[887].Fix(BODY_FORCE_X); -NODES[887].Fix(BODY_FORCE_Y); -NODES[887].Fix(BODY_FORCE_Z); -NODES[888].Fix(BODY_FORCE_X); -NODES[888].Fix(BODY_FORCE_Y); -NODES[888].Fix(BODY_FORCE_Z); -NODES[889].Fix(BODY_FORCE_X); -NODES[889].Fix(BODY_FORCE_Y); -NODES[889].Fix(BODY_FORCE_Z); -NODES[890].Fix(BODY_FORCE_X); -NODES[890].Fix(BODY_FORCE_Y); -NODES[890].Fix(BODY_FORCE_Z); -NODES[891].Fix(BODY_FORCE_X); -NODES[891].Fix(BODY_FORCE_Y); -NODES[891].Fix(BODY_FORCE_Z); -NODES[892].Fix(BODY_FORCE_X); -NODES[892].Fix(BODY_FORCE_Y); -NODES[892].Fix(BODY_FORCE_Z); -NODES[893].Fix(BODY_FORCE_X); -NODES[893].Fix(BODY_FORCE_Y); -NODES[893].Fix(BODY_FORCE_Z); -NODES[894].Fix(BODY_FORCE_X); -NODES[894].Fix(BODY_FORCE_Y); -NODES[894].Fix(BODY_FORCE_Z); -NODES[895].Fix(BODY_FORCE_X); -NODES[895].Fix(BODY_FORCE_Y); -NODES[895].Fix(BODY_FORCE_Z); -NODES[896].Fix(BODY_FORCE_X); -NODES[896].Fix(BODY_FORCE_Y); -NODES[896].Fix(BODY_FORCE_Z); -NODES[897].Fix(BODY_FORCE_X); -NODES[897].Fix(BODY_FORCE_Y); -NODES[897].Fix(BODY_FORCE_Z); -NODES[898].Fix(BODY_FORCE_X); -NODES[898].Fix(BODY_FORCE_Y); -NODES[898].Fix(BODY_FORCE_Z); -NODES[899].Fix(BODY_FORCE_X); -NODES[899].Fix(BODY_FORCE_Y); -NODES[899].Fix(BODY_FORCE_Z); -NODES[900].Fix(BODY_FORCE_X); -NODES[900].Fix(BODY_FORCE_Y); -NODES[900].Fix(BODY_FORCE_Z); -NODES[901].Fix(BODY_FORCE_X); -NODES[901].Fix(BODY_FORCE_Y); -NODES[901].Fix(BODY_FORCE_Z); -NODES[902].Fix(BODY_FORCE_X); -NODES[902].Fix(BODY_FORCE_Y); -NODES[902].Fix(BODY_FORCE_Z); -NODES[903].Fix(BODY_FORCE_X); -NODES[903].Fix(BODY_FORCE_Y); -NODES[903].Fix(BODY_FORCE_Z); -NODES[904].Fix(BODY_FORCE_X); -NODES[904].Fix(BODY_FORCE_Y); -NODES[904].Fix(BODY_FORCE_Z); -NODES[905].Fix(BODY_FORCE_X); -NODES[905].Fix(BODY_FORCE_Y); -NODES[905].Fix(BODY_FORCE_Z); -NODES[906].Fix(BODY_FORCE_X); -NODES[906].Fix(BODY_FORCE_Y); -NODES[906].Fix(BODY_FORCE_Z); -NODES[907].Fix(BODY_FORCE_X); -NODES[907].Fix(BODY_FORCE_Y); -NODES[907].Fix(BODY_FORCE_Z); -NODES[908].Fix(BODY_FORCE_X); -NODES[908].Fix(BODY_FORCE_Y); -NODES[908].Fix(BODY_FORCE_Z); -NODES[909].Fix(BODY_FORCE_X); -NODES[909].Fix(BODY_FORCE_Y); -NODES[909].Fix(BODY_FORCE_Z); -NODES[910].Fix(BODY_FORCE_X); -NODES[910].Fix(BODY_FORCE_Y); -NODES[910].Fix(BODY_FORCE_Z); -NODES[911].Fix(BODY_FORCE_X); -NODES[911].Fix(BODY_FORCE_Y); -NODES[911].Fix(BODY_FORCE_Z); -NODES[912].Fix(BODY_FORCE_X); -NODES[912].Fix(BODY_FORCE_Y); -NODES[912].Fix(BODY_FORCE_Z); -NODES[913].Fix(BODY_FORCE_X); -NODES[913].Fix(BODY_FORCE_Y); -NODES[913].Fix(BODY_FORCE_Z); -NODES[914].Fix(BODY_FORCE_X); -NODES[914].Fix(BODY_FORCE_Y); -NODES[914].Fix(BODY_FORCE_Z); -NODES[915].Fix(BODY_FORCE_X); -NODES[915].Fix(BODY_FORCE_Y); -NODES[915].Fix(BODY_FORCE_Z); -NODES[916].Fix(BODY_FORCE_X); -NODES[916].Fix(BODY_FORCE_Y); -NODES[916].Fix(BODY_FORCE_Z); -NODES[917].Fix(BODY_FORCE_X); -NODES[917].Fix(BODY_FORCE_Y); -NODES[917].Fix(BODY_FORCE_Z); -NODES[918].Fix(BODY_FORCE_X); -NODES[918].Fix(BODY_FORCE_Y); -NODES[918].Fix(BODY_FORCE_Z); -NODES[919].Fix(BODY_FORCE_X); -NODES[919].Fix(BODY_FORCE_Y); -NODES[919].Fix(BODY_FORCE_Z); -NODES[920].Fix(BODY_FORCE_X); -NODES[920].Fix(BODY_FORCE_Y); -NODES[920].Fix(BODY_FORCE_Z); -NODES[921].Fix(BODY_FORCE_X); -NODES[921].Fix(BODY_FORCE_Y); -NODES[921].Fix(BODY_FORCE_Z); -NODES[922].Fix(BODY_FORCE_X); -NODES[922].Fix(BODY_FORCE_Y); -NODES[922].Fix(BODY_FORCE_Z); -NODES[923].Fix(BODY_FORCE_X); -NODES[923].Fix(BODY_FORCE_Y); -NODES[923].Fix(BODY_FORCE_Z); -NODES[924].Fix(BODY_FORCE_X); -NODES[924].Fix(BODY_FORCE_Y); -NODES[924].Fix(BODY_FORCE_Z); -NODES[925].Fix(BODY_FORCE_X); -NODES[925].Fix(BODY_FORCE_Y); -NODES[925].Fix(BODY_FORCE_Z); -NODES[926].Fix(BODY_FORCE_X); -NODES[926].Fix(BODY_FORCE_Y); -NODES[926].Fix(BODY_FORCE_Z); -NODES[927].Fix(BODY_FORCE_X); -NODES[927].Fix(BODY_FORCE_Y); -NODES[927].Fix(BODY_FORCE_Z); -NODES[928].Fix(BODY_FORCE_X); -NODES[928].Fix(BODY_FORCE_Y); -NODES[928].Fix(BODY_FORCE_Z); -NODES[929].Fix(BODY_FORCE_X); -NODES[929].Fix(BODY_FORCE_Y); -NODES[929].Fix(BODY_FORCE_Z); -NODES[930].Fix(BODY_FORCE_X); -NODES[930].Fix(BODY_FORCE_Y); -NODES[930].Fix(BODY_FORCE_Z); -NODES[931].Fix(BODY_FORCE_X); -NODES[931].Fix(BODY_FORCE_Y); -NODES[931].Fix(BODY_FORCE_Z); -NODES[932].Fix(BODY_FORCE_X); -NODES[932].Fix(BODY_FORCE_Y); -NODES[932].Fix(BODY_FORCE_Z); -NODES[933].Fix(BODY_FORCE_X); -NODES[933].Fix(BODY_FORCE_Y); -NODES[933].Fix(BODY_FORCE_Z); -NODES[934].Fix(BODY_FORCE_X); -NODES[934].Fix(BODY_FORCE_Y); -NODES[934].Fix(BODY_FORCE_Z); -NODES[935].Fix(BODY_FORCE_X); -NODES[935].Fix(BODY_FORCE_Y); -NODES[935].Fix(BODY_FORCE_Z); -NODES[936].Fix(BODY_FORCE_X); -NODES[936].Fix(BODY_FORCE_Y); -NODES[936].Fix(BODY_FORCE_Z); -NODES[937].Fix(BODY_FORCE_X); -NODES[937].Fix(BODY_FORCE_Y); -NODES[937].Fix(BODY_FORCE_Z); -NODES[939].Fix(BODY_FORCE_X); -NODES[939].Fix(BODY_FORCE_Y); -NODES[939].Fix(BODY_FORCE_Z); -NODES[940].Fix(BODY_FORCE_X); -NODES[940].Fix(BODY_FORCE_Y); -NODES[940].Fix(BODY_FORCE_Z); -NODES[941].Fix(BODY_FORCE_X); -NODES[941].Fix(BODY_FORCE_Y); -NODES[941].Fix(BODY_FORCE_Z); -NODES[942].Fix(BODY_FORCE_X); -NODES[942].Fix(BODY_FORCE_Y); -NODES[942].Fix(BODY_FORCE_Z); -NODES[943].Fix(BODY_FORCE_X); -NODES[943].Fix(BODY_FORCE_Y); -NODES[943].Fix(BODY_FORCE_Z); -NODES[944].Fix(BODY_FORCE_X); -NODES[944].Fix(BODY_FORCE_Y); -NODES[944].Fix(BODY_FORCE_Z); -NODES[945].Fix(BODY_FORCE_X); -NODES[945].Fix(BODY_FORCE_Y); -NODES[945].Fix(BODY_FORCE_Z); -NODES[946].Fix(BODY_FORCE_X); -NODES[946].Fix(BODY_FORCE_Y); -NODES[946].Fix(BODY_FORCE_Z); -NODES[947].Fix(BODY_FORCE_X); -NODES[947].Fix(BODY_FORCE_Y); -NODES[947].Fix(BODY_FORCE_Z); -NODES[948].Fix(BODY_FORCE_X); -NODES[948].Fix(BODY_FORCE_Y); -NODES[948].Fix(BODY_FORCE_Z); -NODES[949].Fix(BODY_FORCE_X); -NODES[949].Fix(BODY_FORCE_Y); -NODES[949].Fix(BODY_FORCE_Z); -NODES[950].Fix(BODY_FORCE_X); -NODES[950].Fix(BODY_FORCE_Y); -NODES[950].Fix(BODY_FORCE_Z); -NODES[951].Fix(BODY_FORCE_X); -NODES[951].Fix(BODY_FORCE_Y); -NODES[951].Fix(BODY_FORCE_Z); -NODES[952].Fix(BODY_FORCE_X); -NODES[952].Fix(BODY_FORCE_Y); -NODES[952].Fix(BODY_FORCE_Z); -NODES[953].Fix(BODY_FORCE_X); -NODES[953].Fix(BODY_FORCE_Y); -NODES[953].Fix(BODY_FORCE_Z); -NODES[954].Fix(BODY_FORCE_X); -NODES[954].Fix(BODY_FORCE_Y); -NODES[954].Fix(BODY_FORCE_Z); -NODES[955].Fix(BODY_FORCE_X); -NODES[955].Fix(BODY_FORCE_Y); -NODES[955].Fix(BODY_FORCE_Z); -NODES[956].Fix(BODY_FORCE_X); -NODES[956].Fix(BODY_FORCE_Y); -NODES[956].Fix(BODY_FORCE_Z); -NODES[957].Fix(BODY_FORCE_X); -NODES[957].Fix(BODY_FORCE_Y); -NODES[957].Fix(BODY_FORCE_Z); -NODES[958].Fix(BODY_FORCE_X); -NODES[958].Fix(BODY_FORCE_Y); -NODES[958].Fix(BODY_FORCE_Z); -NODES[959].Fix(BODY_FORCE_X); -NODES[959].Fix(BODY_FORCE_Y); -NODES[959].Fix(BODY_FORCE_Z); -NODES[960].Fix(BODY_FORCE_X); -NODES[960].Fix(BODY_FORCE_Y); -NODES[960].Fix(BODY_FORCE_Z); -NODES[961].Fix(BODY_FORCE_X); -NODES[961].Fix(BODY_FORCE_Y); -NODES[961].Fix(BODY_FORCE_Z); -NODES[962].Fix(BODY_FORCE_X); -NODES[962].Fix(BODY_FORCE_Y); -NODES[962].Fix(BODY_FORCE_Z); -NODES[963].Fix(BODY_FORCE_X); -NODES[963].Fix(BODY_FORCE_Y); -NODES[963].Fix(BODY_FORCE_Z); -NODES[964].Fix(BODY_FORCE_X); -NODES[964].Fix(BODY_FORCE_Y); -NODES[964].Fix(BODY_FORCE_Z); -NODES[965].Fix(BODY_FORCE_X); -NODES[965].Fix(BODY_FORCE_Y); -NODES[965].Fix(BODY_FORCE_Z); -NODES[966].Fix(BODY_FORCE_X); -NODES[966].Fix(BODY_FORCE_Y); -NODES[966].Fix(BODY_FORCE_Z); -NODES[967].Fix(BODY_FORCE_X); -NODES[967].Fix(BODY_FORCE_Y); -NODES[967].Fix(BODY_FORCE_Z); -NODES[968].Fix(BODY_FORCE_X); -NODES[968].Fix(BODY_FORCE_Y); -NODES[968].Fix(BODY_FORCE_Z); -NODES[969].Fix(BODY_FORCE_X); -NODES[969].Fix(BODY_FORCE_Y); -NODES[969].Fix(BODY_FORCE_Z); -NODES[970].Fix(BODY_FORCE_X); -NODES[970].Fix(BODY_FORCE_Y); -NODES[970].Fix(BODY_FORCE_Z); -NODES[971].Fix(BODY_FORCE_X); -NODES[971].Fix(BODY_FORCE_Y); -NODES[971].Fix(BODY_FORCE_Z); -NODES[972].Fix(BODY_FORCE_X); -NODES[972].Fix(BODY_FORCE_Y); -NODES[972].Fix(BODY_FORCE_Z); -NODES[973].Fix(BODY_FORCE_X); -NODES[973].Fix(BODY_FORCE_Y); -NODES[973].Fix(BODY_FORCE_Z); -NODES[974].Fix(BODY_FORCE_X); -NODES[974].Fix(BODY_FORCE_Y); -NODES[974].Fix(BODY_FORCE_Z); -NODES[975].Fix(BODY_FORCE_X); -NODES[975].Fix(BODY_FORCE_Y); -NODES[975].Fix(BODY_FORCE_Z); -NODES[976].Fix(BODY_FORCE_X); -NODES[976].Fix(BODY_FORCE_Y); -NODES[976].Fix(BODY_FORCE_Z); -NODES[977].Fix(BODY_FORCE_X); -NODES[977].Fix(BODY_FORCE_Y); -NODES[977].Fix(BODY_FORCE_Z); -NODES[978].Fix(BODY_FORCE_X); -NODES[978].Fix(BODY_FORCE_Y); -NODES[978].Fix(BODY_FORCE_Z); -NODES[979].Fix(BODY_FORCE_X); -NODES[979].Fix(BODY_FORCE_Y); -NODES[979].Fix(BODY_FORCE_Z); -NODES[980].Fix(BODY_FORCE_X); -NODES[980].Fix(BODY_FORCE_Y); -NODES[980].Fix(BODY_FORCE_Z); -NODES[981].Fix(BODY_FORCE_X); -NODES[981].Fix(BODY_FORCE_Y); -NODES[981].Fix(BODY_FORCE_Z); -NODES[982].Fix(BODY_FORCE_X); -NODES[982].Fix(BODY_FORCE_Y); -NODES[982].Fix(BODY_FORCE_Z); -NODES[983].Fix(BODY_FORCE_X); -NODES[983].Fix(BODY_FORCE_Y); -NODES[983].Fix(BODY_FORCE_Z); -NODES[984].Fix(BODY_FORCE_X); -NODES[984].Fix(BODY_FORCE_Y); -NODES[984].Fix(BODY_FORCE_Z); -NODES[985].Fix(BODY_FORCE_X); -NODES[985].Fix(BODY_FORCE_Y); -NODES[985].Fix(BODY_FORCE_Z); -NODES[986].Fix(BODY_FORCE_X); -NODES[986].Fix(BODY_FORCE_Y); -NODES[986].Fix(BODY_FORCE_Z); -NODES[987].Fix(BODY_FORCE_X); -NODES[987].Fix(BODY_FORCE_Y); -NODES[987].Fix(BODY_FORCE_Z); -NODES[988].Fix(BODY_FORCE_X); -NODES[988].Fix(BODY_FORCE_Y); -NODES[988].Fix(BODY_FORCE_Z); -NODES[989].Fix(BODY_FORCE_X); -NODES[989].Fix(BODY_FORCE_Y); -NODES[989].Fix(BODY_FORCE_Z); -NODES[990].Fix(BODY_FORCE_X); -NODES[990].Fix(BODY_FORCE_Y); -NODES[990].Fix(BODY_FORCE_Z); -NODES[991].Fix(BODY_FORCE_X); -NODES[991].Fix(BODY_FORCE_Y); -NODES[991].Fix(BODY_FORCE_Z); -NODES[992].Fix(BODY_FORCE_X); -NODES[992].Fix(BODY_FORCE_Y); -NODES[992].Fix(BODY_FORCE_Z); -NODES[993].Fix(BODY_FORCE_X); -NODES[993].Fix(BODY_FORCE_Y); -NODES[993].Fix(BODY_FORCE_Z); -NODES[994].Fix(BODY_FORCE_X); -NODES[994].Fix(BODY_FORCE_Y); -NODES[994].Fix(BODY_FORCE_Z); -NODES[995].Fix(BODY_FORCE_X); -NODES[995].Fix(BODY_FORCE_Y); -NODES[995].Fix(BODY_FORCE_Z); -NODES[996].Fix(BODY_FORCE_X); -NODES[996].Fix(BODY_FORCE_Y); -NODES[996].Fix(BODY_FORCE_Z); -NODES[997].Fix(BODY_FORCE_X); -NODES[997].Fix(BODY_FORCE_Y); -NODES[997].Fix(BODY_FORCE_Z); -NODES[998].Fix(BODY_FORCE_X); -NODES[998].Fix(BODY_FORCE_Y); -NODES[998].Fix(BODY_FORCE_Z); -NODES[999].Fix(BODY_FORCE_X); -NODES[999].Fix(BODY_FORCE_Y); -NODES[999].Fix(BODY_FORCE_Z); -NODES[1000].Fix(BODY_FORCE_X); -NODES[1000].Fix(BODY_FORCE_Y); -NODES[1000].Fix(BODY_FORCE_Z); -NODES[1001].Fix(BODY_FORCE_X); -NODES[1001].Fix(BODY_FORCE_Y); -NODES[1001].Fix(BODY_FORCE_Z); -NODES[1002].Fix(BODY_FORCE_X); -NODES[1002].Fix(BODY_FORCE_Y); -NODES[1002].Fix(BODY_FORCE_Z); -NODES[1003].Fix(BODY_FORCE_X); -NODES[1003].Fix(BODY_FORCE_Y); -NODES[1003].Fix(BODY_FORCE_Z); -NODES[1004].Fix(BODY_FORCE_X); -NODES[1004].Fix(BODY_FORCE_Y); -NODES[1004].Fix(BODY_FORCE_Z); -NODES[1005].Fix(BODY_FORCE_X); -NODES[1005].Fix(BODY_FORCE_Y); -NODES[1005].Fix(BODY_FORCE_Z); -NODES[1006].Fix(BODY_FORCE_X); -NODES[1006].Fix(BODY_FORCE_Y); -NODES[1006].Fix(BODY_FORCE_Z); -NODES[1007].Fix(BODY_FORCE_X); -NODES[1007].Fix(BODY_FORCE_Y); -NODES[1007].Fix(BODY_FORCE_Z); -NODES[1008].Fix(BODY_FORCE_X); -NODES[1008].Fix(BODY_FORCE_Y); -NODES[1008].Fix(BODY_FORCE_Z); -NODES[1010].Fix(BODY_FORCE_X); -NODES[1010].Fix(BODY_FORCE_Y); -NODES[1010].Fix(BODY_FORCE_Z); -NODES[1011].Fix(BODY_FORCE_X); -NODES[1011].Fix(BODY_FORCE_Y); -NODES[1011].Fix(BODY_FORCE_Z); -NODES[1012].Fix(BODY_FORCE_X); -NODES[1012].Fix(BODY_FORCE_Y); -NODES[1012].Fix(BODY_FORCE_Z); -NODES[1013].Fix(BODY_FORCE_X); -NODES[1013].Fix(BODY_FORCE_Y); -NODES[1013].Fix(BODY_FORCE_Z); -NODES[1014].Fix(BODY_FORCE_X); -NODES[1014].Fix(BODY_FORCE_Y); -NODES[1014].Fix(BODY_FORCE_Z); -NODES[1015].Fix(BODY_FORCE_X); -NODES[1015].Fix(BODY_FORCE_Y); -NODES[1015].Fix(BODY_FORCE_Z); -NODES[1016].Fix(BODY_FORCE_X); -NODES[1016].Fix(BODY_FORCE_Y); -NODES[1016].Fix(BODY_FORCE_Z); -NODES[1017].Fix(BODY_FORCE_X); -NODES[1017].Fix(BODY_FORCE_Y); -NODES[1017].Fix(BODY_FORCE_Z); -NODES[1018].Fix(BODY_FORCE_X); -NODES[1018].Fix(BODY_FORCE_Y); -NODES[1018].Fix(BODY_FORCE_Z); -NODES[1019].Fix(BODY_FORCE_X); -NODES[1019].Fix(BODY_FORCE_Y); -NODES[1019].Fix(BODY_FORCE_Z); -NODES[1020].Fix(BODY_FORCE_X); -NODES[1020].Fix(BODY_FORCE_Y); -NODES[1020].Fix(BODY_FORCE_Z); -NODES[1021].Fix(BODY_FORCE_X); -NODES[1021].Fix(BODY_FORCE_Y); -NODES[1021].Fix(BODY_FORCE_Z); -NODES[1022].Fix(BODY_FORCE_X); -NODES[1022].Fix(BODY_FORCE_Y); -NODES[1022].Fix(BODY_FORCE_Z); -NODES[1023].Fix(BODY_FORCE_X); -NODES[1023].Fix(BODY_FORCE_Y); -NODES[1023].Fix(BODY_FORCE_Z); -NODES[1024].Fix(BODY_FORCE_X); -NODES[1024].Fix(BODY_FORCE_Y); -NODES[1024].Fix(BODY_FORCE_Z); -NODES[1025].Fix(BODY_FORCE_X); -NODES[1025].Fix(BODY_FORCE_Y); -NODES[1025].Fix(BODY_FORCE_Z); -NODES[1026].Fix(BODY_FORCE_X); -NODES[1026].Fix(BODY_FORCE_Y); -NODES[1026].Fix(BODY_FORCE_Z); -NODES[1027].Fix(BODY_FORCE_X); -NODES[1027].Fix(BODY_FORCE_Y); -NODES[1027].Fix(BODY_FORCE_Z); -NODES[1028].Fix(BODY_FORCE_X); -NODES[1028].Fix(BODY_FORCE_Y); -NODES[1028].Fix(BODY_FORCE_Z); -NODES[1029].Fix(BODY_FORCE_X); -NODES[1029].Fix(BODY_FORCE_Y); -NODES[1029].Fix(BODY_FORCE_Z); -NODES[1030].Fix(BODY_FORCE_X); -NODES[1030].Fix(BODY_FORCE_Y); -NODES[1030].Fix(BODY_FORCE_Z); -NODES[1031].Fix(BODY_FORCE_X); -NODES[1031].Fix(BODY_FORCE_Y); -NODES[1031].Fix(BODY_FORCE_Z); -NODES[1032].Fix(BODY_FORCE_X); -NODES[1032].Fix(BODY_FORCE_Y); -NODES[1032].Fix(BODY_FORCE_Z); -NODES[1033].Fix(BODY_FORCE_X); -NODES[1033].Fix(BODY_FORCE_Y); -NODES[1033].Fix(BODY_FORCE_Z); -NODES[1034].Fix(BODY_FORCE_X); -NODES[1034].Fix(BODY_FORCE_Y); -NODES[1034].Fix(BODY_FORCE_Z); -NODES[1035].Fix(BODY_FORCE_X); -NODES[1035].Fix(BODY_FORCE_Y); -NODES[1035].Fix(BODY_FORCE_Z); -NODES[1036].Fix(BODY_FORCE_X); -NODES[1036].Fix(BODY_FORCE_Y); -NODES[1036].Fix(BODY_FORCE_Z); -NODES[1037].Fix(BODY_FORCE_X); -NODES[1037].Fix(BODY_FORCE_Y); -NODES[1037].Fix(BODY_FORCE_Z); -NODES[1038].Fix(BODY_FORCE_X); -NODES[1038].Fix(BODY_FORCE_Y); -NODES[1038].Fix(BODY_FORCE_Z); -NODES[1039].Fix(BODY_FORCE_X); -NODES[1039].Fix(BODY_FORCE_Y); -NODES[1039].Fix(BODY_FORCE_Z); -NODES[1040].Fix(BODY_FORCE_X); -NODES[1040].Fix(BODY_FORCE_Y); -NODES[1040].Fix(BODY_FORCE_Z); -NODES[1041].Fix(BODY_FORCE_X); -NODES[1041].Fix(BODY_FORCE_Y); -NODES[1041].Fix(BODY_FORCE_Z); -NODES[1042].Fix(BODY_FORCE_X); -NODES[1042].Fix(BODY_FORCE_Y); -NODES[1042].Fix(BODY_FORCE_Z); -NODES[1043].Fix(BODY_FORCE_X); -NODES[1043].Fix(BODY_FORCE_Y); -NODES[1043].Fix(BODY_FORCE_Z); -NODES[1044].Fix(BODY_FORCE_X); -NODES[1044].Fix(BODY_FORCE_Y); -NODES[1044].Fix(BODY_FORCE_Z); -NODES[1045].Fix(BODY_FORCE_X); -NODES[1045].Fix(BODY_FORCE_Y); -NODES[1045].Fix(BODY_FORCE_Z); -NODES[1046].Fix(BODY_FORCE_X); -NODES[1046].Fix(BODY_FORCE_Y); -NODES[1046].Fix(BODY_FORCE_Z); -NODES[1047].Fix(BODY_FORCE_X); -NODES[1047].Fix(BODY_FORCE_Y); -NODES[1047].Fix(BODY_FORCE_Z); -NODES[1048].Fix(BODY_FORCE_X); -NODES[1048].Fix(BODY_FORCE_Y); -NODES[1048].Fix(BODY_FORCE_Z); -NODES[1049].Fix(BODY_FORCE_X); -NODES[1049].Fix(BODY_FORCE_Y); -NODES[1049].Fix(BODY_FORCE_Z); -NODES[1050].Fix(BODY_FORCE_X); -NODES[1050].Fix(BODY_FORCE_Y); -NODES[1050].Fix(BODY_FORCE_Z); -NODES[1051].Fix(BODY_FORCE_X); -NODES[1051].Fix(BODY_FORCE_Y); -NODES[1051].Fix(BODY_FORCE_Z); -NODES[1052].Fix(BODY_FORCE_X); -NODES[1052].Fix(BODY_FORCE_Y); -NODES[1052].Fix(BODY_FORCE_Z); -NODES[1053].Fix(BODY_FORCE_X); -NODES[1053].Fix(BODY_FORCE_Y); -NODES[1053].Fix(BODY_FORCE_Z); -NODES[1054].Fix(BODY_FORCE_X); -NODES[1054].Fix(BODY_FORCE_Y); -NODES[1054].Fix(BODY_FORCE_Z); -NODES[1055].Fix(BODY_FORCE_X); -NODES[1055].Fix(BODY_FORCE_Y); -NODES[1055].Fix(BODY_FORCE_Z); -NODES[1056].Fix(BODY_FORCE_X); -NODES[1056].Fix(BODY_FORCE_Y); -NODES[1056].Fix(BODY_FORCE_Z); -NODES[1057].Fix(BODY_FORCE_X); -NODES[1057].Fix(BODY_FORCE_Y); -NODES[1057].Fix(BODY_FORCE_Z); -NODES[1058].Fix(BODY_FORCE_X); -NODES[1058].Fix(BODY_FORCE_Y); -NODES[1058].Fix(BODY_FORCE_Z); -NODES[1059].Fix(BODY_FORCE_X); -NODES[1059].Fix(BODY_FORCE_Y); -NODES[1059].Fix(BODY_FORCE_Z); -NODES[1060].Fix(BODY_FORCE_X); -NODES[1060].Fix(BODY_FORCE_Y); -NODES[1060].Fix(BODY_FORCE_Z); -NODES[1061].Fix(BODY_FORCE_X); -NODES[1061].Fix(BODY_FORCE_Y); -NODES[1061].Fix(BODY_FORCE_Z); -NODES[1062].Fix(BODY_FORCE_X); -NODES[1062].Fix(BODY_FORCE_Y); -NODES[1062].Fix(BODY_FORCE_Z); -NODES[1063].Fix(BODY_FORCE_X); -NODES[1063].Fix(BODY_FORCE_Y); -NODES[1063].Fix(BODY_FORCE_Z); -NODES[1064].Fix(BODY_FORCE_X); -NODES[1064].Fix(BODY_FORCE_Y); -NODES[1064].Fix(BODY_FORCE_Z); -NODES[1065].Fix(BODY_FORCE_X); -NODES[1065].Fix(BODY_FORCE_Y); -NODES[1065].Fix(BODY_FORCE_Z); -NODES[1066].Fix(BODY_FORCE_X); -NODES[1066].Fix(BODY_FORCE_Y); -NODES[1066].Fix(BODY_FORCE_Z); -NODES[1067].Fix(BODY_FORCE_X); -NODES[1067].Fix(BODY_FORCE_Y); -NODES[1067].Fix(BODY_FORCE_Z); -NODES[1068].Fix(BODY_FORCE_X); -NODES[1068].Fix(BODY_FORCE_Y); -NODES[1068].Fix(BODY_FORCE_Z); -NODES[1069].Fix(BODY_FORCE_X); -NODES[1069].Fix(BODY_FORCE_Y); -NODES[1069].Fix(BODY_FORCE_Z); -NODES[1070].Fix(BODY_FORCE_X); -NODES[1070].Fix(BODY_FORCE_Y); -NODES[1070].Fix(BODY_FORCE_Z); -NODES[1071].Fix(BODY_FORCE_X); -NODES[1071].Fix(BODY_FORCE_Y); -NODES[1071].Fix(BODY_FORCE_Z); -NODES[1072].Fix(BODY_FORCE_X); -NODES[1072].Fix(BODY_FORCE_Y); -NODES[1072].Fix(BODY_FORCE_Z); -NODES[1073].Fix(BODY_FORCE_X); -NODES[1073].Fix(BODY_FORCE_Y); -NODES[1073].Fix(BODY_FORCE_Z); -NODES[1074].Fix(BODY_FORCE_X); -NODES[1074].Fix(BODY_FORCE_Y); -NODES[1074].Fix(BODY_FORCE_Z); -NODES[1075].Fix(BODY_FORCE_X); -NODES[1075].Fix(BODY_FORCE_Y); -NODES[1075].Fix(BODY_FORCE_Z); -NODES[1076].Fix(BODY_FORCE_X); -NODES[1076].Fix(BODY_FORCE_Y); -NODES[1076].Fix(BODY_FORCE_Z); -NODES[1077].Fix(BODY_FORCE_X); -NODES[1077].Fix(BODY_FORCE_Y); -NODES[1077].Fix(BODY_FORCE_Z); -NODES[1078].Fix(BODY_FORCE_X); -NODES[1078].Fix(BODY_FORCE_Y); -NODES[1078].Fix(BODY_FORCE_Z); -NODES[1079].Fix(BODY_FORCE_X); -NODES[1079].Fix(BODY_FORCE_Y); -NODES[1079].Fix(BODY_FORCE_Z); -NODES[1081].Fix(BODY_FORCE_X); -NODES[1081].Fix(BODY_FORCE_Y); -NODES[1081].Fix(BODY_FORCE_Z); -NODES[1082].Fix(BODY_FORCE_X); -NODES[1082].Fix(BODY_FORCE_Y); -NODES[1082].Fix(BODY_FORCE_Z); -NODES[1083].Fix(BODY_FORCE_X); -NODES[1083].Fix(BODY_FORCE_Y); -NODES[1083].Fix(BODY_FORCE_Z); -NODES[1084].Fix(BODY_FORCE_X); -NODES[1084].Fix(BODY_FORCE_Y); -NODES[1084].Fix(BODY_FORCE_Z); -NODES[1085].Fix(BODY_FORCE_X); -NODES[1085].Fix(BODY_FORCE_Y); -NODES[1085].Fix(BODY_FORCE_Z); -NODES[1086].Fix(BODY_FORCE_X); -NODES[1086].Fix(BODY_FORCE_Y); -NODES[1086].Fix(BODY_FORCE_Z); -NODES[1087].Fix(BODY_FORCE_X); -NODES[1087].Fix(BODY_FORCE_Y); -NODES[1087].Fix(BODY_FORCE_Z); -NODES[1088].Fix(BODY_FORCE_X); -NODES[1088].Fix(BODY_FORCE_Y); -NODES[1088].Fix(BODY_FORCE_Z); -NODES[1089].Fix(BODY_FORCE_X); -NODES[1089].Fix(BODY_FORCE_Y); -NODES[1089].Fix(BODY_FORCE_Z); -NODES[1090].Fix(BODY_FORCE_X); -NODES[1090].Fix(BODY_FORCE_Y); -NODES[1090].Fix(BODY_FORCE_Z); -NODES[1091].Fix(BODY_FORCE_X); -NODES[1091].Fix(BODY_FORCE_Y); -NODES[1091].Fix(BODY_FORCE_Z); -NODES[1092].Fix(BODY_FORCE_X); -NODES[1092].Fix(BODY_FORCE_Y); -NODES[1092].Fix(BODY_FORCE_Z); -NODES[1093].Fix(BODY_FORCE_X); -NODES[1093].Fix(BODY_FORCE_Y); -NODES[1093].Fix(BODY_FORCE_Z); -NODES[1094].Fix(BODY_FORCE_X); -NODES[1094].Fix(BODY_FORCE_Y); -NODES[1094].Fix(BODY_FORCE_Z); -NODES[1095].Fix(BODY_FORCE_X); -NODES[1095].Fix(BODY_FORCE_Y); -NODES[1095].Fix(BODY_FORCE_Z); -NODES[1096].Fix(BODY_FORCE_X); -NODES[1096].Fix(BODY_FORCE_Y); -NODES[1096].Fix(BODY_FORCE_Z); -NODES[1097].Fix(BODY_FORCE_X); -NODES[1097].Fix(BODY_FORCE_Y); -NODES[1097].Fix(BODY_FORCE_Z); -NODES[1098].Fix(BODY_FORCE_X); -NODES[1098].Fix(BODY_FORCE_Y); -NODES[1098].Fix(BODY_FORCE_Z); -NODES[1099].Fix(BODY_FORCE_X); -NODES[1099].Fix(BODY_FORCE_Y); -NODES[1099].Fix(BODY_FORCE_Z); -NODES[1100].Fix(BODY_FORCE_X); -NODES[1100].Fix(BODY_FORCE_Y); -NODES[1100].Fix(BODY_FORCE_Z); -NODES[1101].Fix(BODY_FORCE_X); -NODES[1101].Fix(BODY_FORCE_Y); -NODES[1101].Fix(BODY_FORCE_Z); -NODES[1102].Fix(BODY_FORCE_X); -NODES[1102].Fix(BODY_FORCE_Y); -NODES[1102].Fix(BODY_FORCE_Z); -NODES[1103].Fix(BODY_FORCE_X); -NODES[1103].Fix(BODY_FORCE_Y); -NODES[1103].Fix(BODY_FORCE_Z); -NODES[1104].Fix(BODY_FORCE_X); -NODES[1104].Fix(BODY_FORCE_Y); -NODES[1104].Fix(BODY_FORCE_Z); -NODES[1105].Fix(BODY_FORCE_X); -NODES[1105].Fix(BODY_FORCE_Y); -NODES[1105].Fix(BODY_FORCE_Z); -NODES[1106].Fix(BODY_FORCE_X); -NODES[1106].Fix(BODY_FORCE_Y); -NODES[1106].Fix(BODY_FORCE_Z); -NODES[1107].Fix(BODY_FORCE_X); -NODES[1107].Fix(BODY_FORCE_Y); -NODES[1107].Fix(BODY_FORCE_Z); -NODES[1108].Fix(BODY_FORCE_X); -NODES[1108].Fix(BODY_FORCE_Y); -NODES[1108].Fix(BODY_FORCE_Z); -NODES[1109].Fix(BODY_FORCE_X); -NODES[1109].Fix(BODY_FORCE_Y); -NODES[1109].Fix(BODY_FORCE_Z); -NODES[1110].Fix(BODY_FORCE_X); -NODES[1110].Fix(BODY_FORCE_Y); -NODES[1110].Fix(BODY_FORCE_Z); -NODES[1111].Fix(BODY_FORCE_X); -NODES[1111].Fix(BODY_FORCE_Y); -NODES[1111].Fix(BODY_FORCE_Z); -NODES[1112].Fix(BODY_FORCE_X); -NODES[1112].Fix(BODY_FORCE_Y); -NODES[1112].Fix(BODY_FORCE_Z); -NODES[1113].Fix(BODY_FORCE_X); -NODES[1113].Fix(BODY_FORCE_Y); -NODES[1113].Fix(BODY_FORCE_Z); -NODES[1114].Fix(BODY_FORCE_X); -NODES[1114].Fix(BODY_FORCE_Y); -NODES[1114].Fix(BODY_FORCE_Z); -NODES[1115].Fix(BODY_FORCE_X); -NODES[1115].Fix(BODY_FORCE_Y); -NODES[1115].Fix(BODY_FORCE_Z); -NODES[1116].Fix(BODY_FORCE_X); -NODES[1116].Fix(BODY_FORCE_Y); -NODES[1116].Fix(BODY_FORCE_Z); -NODES[1117].Fix(BODY_FORCE_X); -NODES[1117].Fix(BODY_FORCE_Y); -NODES[1117].Fix(BODY_FORCE_Z); -NODES[1118].Fix(BODY_FORCE_X); -NODES[1118].Fix(BODY_FORCE_Y); -NODES[1118].Fix(BODY_FORCE_Z); -NODES[1119].Fix(BODY_FORCE_X); -NODES[1119].Fix(BODY_FORCE_Y); -NODES[1119].Fix(BODY_FORCE_Z); -NODES[1120].Fix(BODY_FORCE_X); -NODES[1120].Fix(BODY_FORCE_Y); -NODES[1120].Fix(BODY_FORCE_Z); -NODES[1121].Fix(BODY_FORCE_X); -NODES[1121].Fix(BODY_FORCE_Y); -NODES[1121].Fix(BODY_FORCE_Z); -NODES[1122].Fix(BODY_FORCE_X); -NODES[1122].Fix(BODY_FORCE_Y); -NODES[1122].Fix(BODY_FORCE_Z); -NODES[1123].Fix(BODY_FORCE_X); -NODES[1123].Fix(BODY_FORCE_Y); -NODES[1123].Fix(BODY_FORCE_Z); -NODES[1124].Fix(BODY_FORCE_X); -NODES[1124].Fix(BODY_FORCE_Y); -NODES[1124].Fix(BODY_FORCE_Z); -NODES[1125].Fix(BODY_FORCE_X); -NODES[1125].Fix(BODY_FORCE_Y); -NODES[1125].Fix(BODY_FORCE_Z); -NODES[1126].Fix(BODY_FORCE_X); -NODES[1126].Fix(BODY_FORCE_Y); -NODES[1126].Fix(BODY_FORCE_Z); -NODES[1127].Fix(BODY_FORCE_X); -NODES[1127].Fix(BODY_FORCE_Y); -NODES[1127].Fix(BODY_FORCE_Z); -NODES[1128].Fix(BODY_FORCE_X); -NODES[1128].Fix(BODY_FORCE_Y); -NODES[1128].Fix(BODY_FORCE_Z); -NODES[1129].Fix(BODY_FORCE_X); -NODES[1129].Fix(BODY_FORCE_Y); -NODES[1129].Fix(BODY_FORCE_Z); -NODES[1130].Fix(BODY_FORCE_X); -NODES[1130].Fix(BODY_FORCE_Y); -NODES[1130].Fix(BODY_FORCE_Z); -NODES[1131].Fix(BODY_FORCE_X); -NODES[1131].Fix(BODY_FORCE_Y); -NODES[1131].Fix(BODY_FORCE_Z); -NODES[1132].Fix(BODY_FORCE_X); -NODES[1132].Fix(BODY_FORCE_Y); -NODES[1132].Fix(BODY_FORCE_Z); -NODES[1133].Fix(BODY_FORCE_X); -NODES[1133].Fix(BODY_FORCE_Y); -NODES[1133].Fix(BODY_FORCE_Z); -NODES[1134].Fix(BODY_FORCE_X); -NODES[1134].Fix(BODY_FORCE_Y); -NODES[1134].Fix(BODY_FORCE_Z); -NODES[1135].Fix(BODY_FORCE_X); -NODES[1135].Fix(BODY_FORCE_Y); -NODES[1135].Fix(BODY_FORCE_Z); -NODES[1136].Fix(BODY_FORCE_X); -NODES[1136].Fix(BODY_FORCE_Y); -NODES[1136].Fix(BODY_FORCE_Z); -NODES[1137].Fix(BODY_FORCE_X); -NODES[1137].Fix(BODY_FORCE_Y); -NODES[1137].Fix(BODY_FORCE_Z); -NODES[1138].Fix(BODY_FORCE_X); -NODES[1138].Fix(BODY_FORCE_Y); -NODES[1138].Fix(BODY_FORCE_Z); -NODES[1139].Fix(BODY_FORCE_X); -NODES[1139].Fix(BODY_FORCE_Y); -NODES[1139].Fix(BODY_FORCE_Z); -NODES[1141].Fix(BODY_FORCE_X); -NODES[1141].Fix(BODY_FORCE_Y); -NODES[1141].Fix(BODY_FORCE_Z); -NODES[1142].Fix(BODY_FORCE_X); -NODES[1142].Fix(BODY_FORCE_Y); -NODES[1142].Fix(BODY_FORCE_Z); -NODES[1143].Fix(BODY_FORCE_X); -NODES[1143].Fix(BODY_FORCE_Y); -NODES[1143].Fix(BODY_FORCE_Z); -NODES[1144].Fix(BODY_FORCE_X); -NODES[1144].Fix(BODY_FORCE_Y); -NODES[1144].Fix(BODY_FORCE_Z); -NODES[1145].Fix(BODY_FORCE_X); -NODES[1145].Fix(BODY_FORCE_Y); -NODES[1145].Fix(BODY_FORCE_Z); -NODES[1146].Fix(BODY_FORCE_X); -NODES[1146].Fix(BODY_FORCE_Y); -NODES[1146].Fix(BODY_FORCE_Z); -NODES[1147].Fix(BODY_FORCE_X); -NODES[1147].Fix(BODY_FORCE_Y); -NODES[1147].Fix(BODY_FORCE_Z); -NODES[1148].Fix(BODY_FORCE_X); -NODES[1148].Fix(BODY_FORCE_Y); -NODES[1148].Fix(BODY_FORCE_Z); -NODES[1149].Fix(BODY_FORCE_X); -NODES[1149].Fix(BODY_FORCE_Y); -NODES[1149].Fix(BODY_FORCE_Z); -NODES[1150].Fix(BODY_FORCE_X); -NODES[1150].Fix(BODY_FORCE_Y); -NODES[1150].Fix(BODY_FORCE_Z); -NODES[1151].Fix(BODY_FORCE_X); -NODES[1151].Fix(BODY_FORCE_Y); -NODES[1151].Fix(BODY_FORCE_Z); -NODES[1152].Fix(BODY_FORCE_X); -NODES[1152].Fix(BODY_FORCE_Y); -NODES[1152].Fix(BODY_FORCE_Z); -NODES[1153].Fix(BODY_FORCE_X); -NODES[1153].Fix(BODY_FORCE_Y); -NODES[1153].Fix(BODY_FORCE_Z); -NODES[1154].Fix(BODY_FORCE_X); -NODES[1154].Fix(BODY_FORCE_Y); -NODES[1154].Fix(BODY_FORCE_Z); -NODES[1155].Fix(BODY_FORCE_X); -NODES[1155].Fix(BODY_FORCE_Y); -NODES[1155].Fix(BODY_FORCE_Z); -NODES[1156].Fix(BODY_FORCE_X); -NODES[1156].Fix(BODY_FORCE_Y); -NODES[1156].Fix(BODY_FORCE_Z); -NODES[1157].Fix(BODY_FORCE_X); -NODES[1157].Fix(BODY_FORCE_Y); -NODES[1157].Fix(BODY_FORCE_Z); -NODES[1158].Fix(BODY_FORCE_X); -NODES[1158].Fix(BODY_FORCE_Y); -NODES[1158].Fix(BODY_FORCE_Z); -NODES[1159].Fix(BODY_FORCE_X); -NODES[1159].Fix(BODY_FORCE_Y); -NODES[1159].Fix(BODY_FORCE_Z); -NODES[1160].Fix(BODY_FORCE_X); -NODES[1160].Fix(BODY_FORCE_Y); -NODES[1160].Fix(BODY_FORCE_Z); -NODES[1161].Fix(BODY_FORCE_X); -NODES[1161].Fix(BODY_FORCE_Y); -NODES[1161].Fix(BODY_FORCE_Z); -NODES[1162].Fix(BODY_FORCE_X); -NODES[1162].Fix(BODY_FORCE_Y); -NODES[1162].Fix(BODY_FORCE_Z); -NODES[1163].Fix(BODY_FORCE_X); -NODES[1163].Fix(BODY_FORCE_Y); -NODES[1163].Fix(BODY_FORCE_Z); -NODES[1164].Fix(BODY_FORCE_X); -NODES[1164].Fix(BODY_FORCE_Y); -NODES[1164].Fix(BODY_FORCE_Z); -NODES[1165].Fix(BODY_FORCE_X); -NODES[1165].Fix(BODY_FORCE_Y); -NODES[1165].Fix(BODY_FORCE_Z); -NODES[1166].Fix(BODY_FORCE_X); -NODES[1166].Fix(BODY_FORCE_Y); -NODES[1166].Fix(BODY_FORCE_Z); -NODES[1167].Fix(BODY_FORCE_X); -NODES[1167].Fix(BODY_FORCE_Y); -NODES[1167].Fix(BODY_FORCE_Z); -NODES[1168].Fix(BODY_FORCE_X); -NODES[1168].Fix(BODY_FORCE_Y); -NODES[1168].Fix(BODY_FORCE_Z); -NODES[1169].Fix(BODY_FORCE_X); -NODES[1169].Fix(BODY_FORCE_Y); -NODES[1169].Fix(BODY_FORCE_Z); -NODES[1170].Fix(BODY_FORCE_X); -NODES[1170].Fix(BODY_FORCE_Y); -NODES[1170].Fix(BODY_FORCE_Z); -NODES[1171].Fix(BODY_FORCE_X); -NODES[1171].Fix(BODY_FORCE_Y); -NODES[1171].Fix(BODY_FORCE_Z); -NODES[1172].Fix(BODY_FORCE_X); -NODES[1172].Fix(BODY_FORCE_Y); -NODES[1172].Fix(BODY_FORCE_Z); -NODES[1173].Fix(BODY_FORCE_X); -NODES[1173].Fix(BODY_FORCE_Y); -NODES[1173].Fix(BODY_FORCE_Z); -NODES[1174].Fix(BODY_FORCE_X); -NODES[1174].Fix(BODY_FORCE_Y); -NODES[1174].Fix(BODY_FORCE_Z); -NODES[1175].Fix(BODY_FORCE_X); -NODES[1175].Fix(BODY_FORCE_Y); -NODES[1175].Fix(BODY_FORCE_Z); -NODES[1176].Fix(BODY_FORCE_X); -NODES[1176].Fix(BODY_FORCE_Y); -NODES[1176].Fix(BODY_FORCE_Z); -NODES[1177].Fix(BODY_FORCE_X); -NODES[1177].Fix(BODY_FORCE_Y); -NODES[1177].Fix(BODY_FORCE_Z); -NODES[1178].Fix(BODY_FORCE_X); -NODES[1178].Fix(BODY_FORCE_Y); -NODES[1178].Fix(BODY_FORCE_Z); -NODES[1179].Fix(BODY_FORCE_X); -NODES[1179].Fix(BODY_FORCE_Y); -NODES[1179].Fix(BODY_FORCE_Z); -NODES[1180].Fix(BODY_FORCE_X); -NODES[1180].Fix(BODY_FORCE_Y); -NODES[1180].Fix(BODY_FORCE_Z); -NODES[1181].Fix(BODY_FORCE_X); -NODES[1181].Fix(BODY_FORCE_Y); -NODES[1181].Fix(BODY_FORCE_Z); -NODES[1182].Fix(BODY_FORCE_X); -NODES[1182].Fix(BODY_FORCE_Y); -NODES[1182].Fix(BODY_FORCE_Z); -NODES[1183].Fix(BODY_FORCE_X); -NODES[1183].Fix(BODY_FORCE_Y); -NODES[1183].Fix(BODY_FORCE_Z); -NODES[1184].Fix(BODY_FORCE_X); -NODES[1184].Fix(BODY_FORCE_Y); -NODES[1184].Fix(BODY_FORCE_Z); -NODES[1185].Fix(BODY_FORCE_X); -NODES[1185].Fix(BODY_FORCE_Y); -NODES[1185].Fix(BODY_FORCE_Z); -NODES[1186].Fix(BODY_FORCE_X); -NODES[1186].Fix(BODY_FORCE_Y); -NODES[1186].Fix(BODY_FORCE_Z); -NODES[1187].Fix(BODY_FORCE_X); -NODES[1187].Fix(BODY_FORCE_Y); -NODES[1187].Fix(BODY_FORCE_Z); -NODES[1188].Fix(BODY_FORCE_X); -NODES[1188].Fix(BODY_FORCE_Y); -NODES[1188].Fix(BODY_FORCE_Z); -NODES[1189].Fix(BODY_FORCE_X); -NODES[1189].Fix(BODY_FORCE_Y); -NODES[1189].Fix(BODY_FORCE_Z); -NODES[1190].Fix(BODY_FORCE_X); -NODES[1190].Fix(BODY_FORCE_Y); -NODES[1190].Fix(BODY_FORCE_Z); -NODES[1191].Fix(BODY_FORCE_X); -NODES[1191].Fix(BODY_FORCE_Y); -NODES[1191].Fix(BODY_FORCE_Z); -NODES[1192].Fix(BODY_FORCE_X); -NODES[1192].Fix(BODY_FORCE_Y); -NODES[1192].Fix(BODY_FORCE_Z); -NODES[1193].Fix(BODY_FORCE_X); -NODES[1193].Fix(BODY_FORCE_Y); -NODES[1193].Fix(BODY_FORCE_Z); -NODES[1194].Fix(BODY_FORCE_X); -NODES[1194].Fix(BODY_FORCE_Y); -NODES[1194].Fix(BODY_FORCE_Z); -NODES[1195].Fix(BODY_FORCE_X); -NODES[1195].Fix(BODY_FORCE_Y); -NODES[1195].Fix(BODY_FORCE_Z); -NODES[1196].Fix(BODY_FORCE_X); -NODES[1196].Fix(BODY_FORCE_Y); -NODES[1196].Fix(BODY_FORCE_Z); -NODES[1197].Fix(BODY_FORCE_X); -NODES[1197].Fix(BODY_FORCE_Y); -NODES[1197].Fix(BODY_FORCE_Z); -NODES[1198].Fix(BODY_FORCE_X); -NODES[1198].Fix(BODY_FORCE_Y); -NODES[1198].Fix(BODY_FORCE_Z); -NODES[1199].Fix(BODY_FORCE_X); -NODES[1199].Fix(BODY_FORCE_Y); -NODES[1199].Fix(BODY_FORCE_Z); -NODES[1201].Fix(BODY_FORCE_X); -NODES[1201].Fix(BODY_FORCE_Y); -NODES[1201].Fix(BODY_FORCE_Z); -NODES[1202].Fix(BODY_FORCE_X); -NODES[1202].Fix(BODY_FORCE_Y); -NODES[1202].Fix(BODY_FORCE_Z); -NODES[1203].Fix(BODY_FORCE_X); -NODES[1203].Fix(BODY_FORCE_Y); -NODES[1203].Fix(BODY_FORCE_Z); -NODES[1204].Fix(BODY_FORCE_X); -NODES[1204].Fix(BODY_FORCE_Y); -NODES[1204].Fix(BODY_FORCE_Z); -NODES[1205].Fix(BODY_FORCE_X); -NODES[1205].Fix(BODY_FORCE_Y); -NODES[1205].Fix(BODY_FORCE_Z); -NODES[1206].Fix(BODY_FORCE_X); -NODES[1206].Fix(BODY_FORCE_Y); -NODES[1206].Fix(BODY_FORCE_Z); -NODES[1207].Fix(BODY_FORCE_X); -NODES[1207].Fix(BODY_FORCE_Y); -NODES[1207].Fix(BODY_FORCE_Z); -NODES[1208].Fix(BODY_FORCE_X); -NODES[1208].Fix(BODY_FORCE_Y); -NODES[1208].Fix(BODY_FORCE_Z); -NODES[1209].Fix(BODY_FORCE_X); -NODES[1209].Fix(BODY_FORCE_Y); -NODES[1209].Fix(BODY_FORCE_Z); -NODES[1210].Fix(BODY_FORCE_X); -NODES[1210].Fix(BODY_FORCE_Y); -NODES[1210].Fix(BODY_FORCE_Z); -NODES[1211].Fix(BODY_FORCE_X); -NODES[1211].Fix(BODY_FORCE_Y); -NODES[1211].Fix(BODY_FORCE_Z); -NODES[1212].Fix(BODY_FORCE_X); -NODES[1212].Fix(BODY_FORCE_Y); -NODES[1212].Fix(BODY_FORCE_Z); -NODES[1213].Fix(BODY_FORCE_X); -NODES[1213].Fix(BODY_FORCE_Y); -NODES[1213].Fix(BODY_FORCE_Z); -NODES[1214].Fix(BODY_FORCE_X); -NODES[1214].Fix(BODY_FORCE_Y); -NODES[1214].Fix(BODY_FORCE_Z); -NODES[1215].Fix(BODY_FORCE_X); -NODES[1215].Fix(BODY_FORCE_Y); -NODES[1215].Fix(BODY_FORCE_Z); -NODES[1216].Fix(BODY_FORCE_X); -NODES[1216].Fix(BODY_FORCE_Y); -NODES[1216].Fix(BODY_FORCE_Z); -NODES[1217].Fix(BODY_FORCE_X); -NODES[1217].Fix(BODY_FORCE_Y); -NODES[1217].Fix(BODY_FORCE_Z); -NODES[1218].Fix(BODY_FORCE_X); -NODES[1218].Fix(BODY_FORCE_Y); -NODES[1218].Fix(BODY_FORCE_Z); -NODES[1219].Fix(BODY_FORCE_X); -NODES[1219].Fix(BODY_FORCE_Y); -NODES[1219].Fix(BODY_FORCE_Z); -NODES[1220].Fix(BODY_FORCE_X); -NODES[1220].Fix(BODY_FORCE_Y); -NODES[1220].Fix(BODY_FORCE_Z); -NODES[1221].Fix(BODY_FORCE_X); -NODES[1221].Fix(BODY_FORCE_Y); -NODES[1221].Fix(BODY_FORCE_Z); -NODES[1222].Fix(BODY_FORCE_X); -NODES[1222].Fix(BODY_FORCE_Y); -NODES[1222].Fix(BODY_FORCE_Z); -NODES[1223].Fix(BODY_FORCE_X); -NODES[1223].Fix(BODY_FORCE_Y); -NODES[1223].Fix(BODY_FORCE_Z); -NODES[1224].Fix(BODY_FORCE_X); -NODES[1224].Fix(BODY_FORCE_Y); -NODES[1224].Fix(BODY_FORCE_Z); -NODES[1225].Fix(BODY_FORCE_X); -NODES[1225].Fix(BODY_FORCE_Y); -NODES[1225].Fix(BODY_FORCE_Z); -NODES[1226].Fix(BODY_FORCE_X); -NODES[1226].Fix(BODY_FORCE_Y); -NODES[1226].Fix(BODY_FORCE_Z); -NODES[1227].Fix(BODY_FORCE_X); -NODES[1227].Fix(BODY_FORCE_Y); -NODES[1227].Fix(BODY_FORCE_Z); -NODES[1228].Fix(BODY_FORCE_X); -NODES[1228].Fix(BODY_FORCE_Y); -NODES[1228].Fix(BODY_FORCE_Z); -NODES[1229].Fix(BODY_FORCE_X); -NODES[1229].Fix(BODY_FORCE_Y); -NODES[1229].Fix(BODY_FORCE_Z); -NODES[1230].Fix(BODY_FORCE_X); -NODES[1230].Fix(BODY_FORCE_Y); -NODES[1230].Fix(BODY_FORCE_Z); -NODES[1231].Fix(BODY_FORCE_X); -NODES[1231].Fix(BODY_FORCE_Y); -NODES[1231].Fix(BODY_FORCE_Z); -NODES[1232].Fix(BODY_FORCE_X); -NODES[1232].Fix(BODY_FORCE_Y); -NODES[1232].Fix(BODY_FORCE_Z); -NODES[1233].Fix(BODY_FORCE_X); -NODES[1233].Fix(BODY_FORCE_Y); -NODES[1233].Fix(BODY_FORCE_Z); -NODES[1234].Fix(BODY_FORCE_X); -NODES[1234].Fix(BODY_FORCE_Y); -NODES[1234].Fix(BODY_FORCE_Z); -NODES[1235].Fix(BODY_FORCE_X); -NODES[1235].Fix(BODY_FORCE_Y); -NODES[1235].Fix(BODY_FORCE_Z); -NODES[1236].Fix(BODY_FORCE_X); -NODES[1236].Fix(BODY_FORCE_Y); -NODES[1236].Fix(BODY_FORCE_Z); -NODES[1237].Fix(BODY_FORCE_X); -NODES[1237].Fix(BODY_FORCE_Y); -NODES[1237].Fix(BODY_FORCE_Z); -NODES[1238].Fix(BODY_FORCE_X); -NODES[1238].Fix(BODY_FORCE_Y); -NODES[1238].Fix(BODY_FORCE_Z); -NODES[1239].Fix(BODY_FORCE_X); -NODES[1239].Fix(BODY_FORCE_Y); -NODES[1239].Fix(BODY_FORCE_Z); -NODES[1240].Fix(BODY_FORCE_X); -NODES[1240].Fix(BODY_FORCE_Y); -NODES[1240].Fix(BODY_FORCE_Z); -NODES[1241].Fix(BODY_FORCE_X); -NODES[1241].Fix(BODY_FORCE_Y); -NODES[1241].Fix(BODY_FORCE_Z); -NODES[1242].Fix(BODY_FORCE_X); -NODES[1242].Fix(BODY_FORCE_Y); -NODES[1242].Fix(BODY_FORCE_Z); -NODES[1243].Fix(BODY_FORCE_X); -NODES[1243].Fix(BODY_FORCE_Y); -NODES[1243].Fix(BODY_FORCE_Z); -NODES[1244].Fix(BODY_FORCE_X); -NODES[1244].Fix(BODY_FORCE_Y); -NODES[1244].Fix(BODY_FORCE_Z); -NODES[1245].Fix(BODY_FORCE_X); -NODES[1245].Fix(BODY_FORCE_Y); -NODES[1245].Fix(BODY_FORCE_Z); -NODES[1246].Fix(BODY_FORCE_X); -NODES[1246].Fix(BODY_FORCE_Y); -NODES[1246].Fix(BODY_FORCE_Z); -NODES[1247].Fix(BODY_FORCE_X); -NODES[1247].Fix(BODY_FORCE_Y); -NODES[1247].Fix(BODY_FORCE_Z); -NODES[1248].Fix(BODY_FORCE_X); -NODES[1248].Fix(BODY_FORCE_Y); -NODES[1248].Fix(BODY_FORCE_Z); -NODES[1249].Fix(BODY_FORCE_X); -NODES[1249].Fix(BODY_FORCE_Y); -NODES[1249].Fix(BODY_FORCE_Z); -NODES[1250].Fix(BODY_FORCE_X); -NODES[1250].Fix(BODY_FORCE_Y); -NODES[1250].Fix(BODY_FORCE_Z); -NODES[1251].Fix(BODY_FORCE_X); -NODES[1251].Fix(BODY_FORCE_Y); -NODES[1251].Fix(BODY_FORCE_Z); -NODES[1253].Fix(BODY_FORCE_X); -NODES[1253].Fix(BODY_FORCE_Y); -NODES[1253].Fix(BODY_FORCE_Z); -NODES[1254].Fix(BODY_FORCE_X); -NODES[1254].Fix(BODY_FORCE_Y); -NODES[1254].Fix(BODY_FORCE_Z); -NODES[1255].Fix(BODY_FORCE_X); -NODES[1255].Fix(BODY_FORCE_Y); -NODES[1255].Fix(BODY_FORCE_Z); -NODES[1256].Fix(BODY_FORCE_X); -NODES[1256].Fix(BODY_FORCE_Y); -NODES[1256].Fix(BODY_FORCE_Z); -NODES[1257].Fix(BODY_FORCE_X); -NODES[1257].Fix(BODY_FORCE_Y); -NODES[1257].Fix(BODY_FORCE_Z); -NODES[1258].Fix(BODY_FORCE_X); -NODES[1258].Fix(BODY_FORCE_Y); -NODES[1258].Fix(BODY_FORCE_Z); -NODES[1259].Fix(BODY_FORCE_X); -NODES[1259].Fix(BODY_FORCE_Y); -NODES[1259].Fix(BODY_FORCE_Z); -NODES[1260].Fix(BODY_FORCE_X); -NODES[1260].Fix(BODY_FORCE_Y); -NODES[1260].Fix(BODY_FORCE_Z); -NODES[1261].Fix(BODY_FORCE_X); -NODES[1261].Fix(BODY_FORCE_Y); -NODES[1261].Fix(BODY_FORCE_Z); -NODES[1262].Fix(BODY_FORCE_X); -NODES[1262].Fix(BODY_FORCE_Y); -NODES[1262].Fix(BODY_FORCE_Z); -NODES[1263].Fix(BODY_FORCE_X); -NODES[1263].Fix(BODY_FORCE_Y); -NODES[1263].Fix(BODY_FORCE_Z); -NODES[1264].Fix(BODY_FORCE_X); -NODES[1264].Fix(BODY_FORCE_Y); -NODES[1264].Fix(BODY_FORCE_Z); -NODES[1265].Fix(BODY_FORCE_X); -NODES[1265].Fix(BODY_FORCE_Y); -NODES[1265].Fix(BODY_FORCE_Z); -NODES[1266].Fix(BODY_FORCE_X); -NODES[1266].Fix(BODY_FORCE_Y); -NODES[1266].Fix(BODY_FORCE_Z); -NODES[1267].Fix(BODY_FORCE_X); -NODES[1267].Fix(BODY_FORCE_Y); -NODES[1267].Fix(BODY_FORCE_Z); -NODES[1268].Fix(BODY_FORCE_X); -NODES[1268].Fix(BODY_FORCE_Y); -NODES[1268].Fix(BODY_FORCE_Z); -NODES[1269].Fix(BODY_FORCE_X); -NODES[1269].Fix(BODY_FORCE_Y); -NODES[1269].Fix(BODY_FORCE_Z); -NODES[1270].Fix(BODY_FORCE_X); -NODES[1270].Fix(BODY_FORCE_Y); -NODES[1270].Fix(BODY_FORCE_Z); -NODES[1271].Fix(BODY_FORCE_X); -NODES[1271].Fix(BODY_FORCE_Y); -NODES[1271].Fix(BODY_FORCE_Z); -NODES[1272].Fix(BODY_FORCE_X); -NODES[1272].Fix(BODY_FORCE_Y); -NODES[1272].Fix(BODY_FORCE_Z); -NODES[1273].Fix(BODY_FORCE_X); -NODES[1273].Fix(BODY_FORCE_Y); -NODES[1273].Fix(BODY_FORCE_Z); -NODES[1274].Fix(BODY_FORCE_X); -NODES[1274].Fix(BODY_FORCE_Y); -NODES[1274].Fix(BODY_FORCE_Z); -NODES[1275].Fix(BODY_FORCE_X); -NODES[1275].Fix(BODY_FORCE_Y); -NODES[1275].Fix(BODY_FORCE_Z); -NODES[1276].Fix(BODY_FORCE_X); -NODES[1276].Fix(BODY_FORCE_Y); -NODES[1276].Fix(BODY_FORCE_Z); -NODES[1277].Fix(BODY_FORCE_X); -NODES[1277].Fix(BODY_FORCE_Y); -NODES[1277].Fix(BODY_FORCE_Z); -NODES[1278].Fix(BODY_FORCE_X); -NODES[1278].Fix(BODY_FORCE_Y); -NODES[1278].Fix(BODY_FORCE_Z); -NODES[1279].Fix(BODY_FORCE_X); -NODES[1279].Fix(BODY_FORCE_Y); -NODES[1279].Fix(BODY_FORCE_Z); -NODES[1280].Fix(BODY_FORCE_X); -NODES[1280].Fix(BODY_FORCE_Y); -NODES[1280].Fix(BODY_FORCE_Z); -NODES[1281].Fix(BODY_FORCE_X); -NODES[1281].Fix(BODY_FORCE_Y); -NODES[1281].Fix(BODY_FORCE_Z); -NODES[1282].Fix(BODY_FORCE_X); -NODES[1282].Fix(BODY_FORCE_Y); -NODES[1282].Fix(BODY_FORCE_Z); -NODES[1283].Fix(BODY_FORCE_X); -NODES[1283].Fix(BODY_FORCE_Y); -NODES[1283].Fix(BODY_FORCE_Z); -NODES[1284].Fix(BODY_FORCE_X); -NODES[1284].Fix(BODY_FORCE_Y); -NODES[1284].Fix(BODY_FORCE_Z); -NODES[1285].Fix(BODY_FORCE_X); -NODES[1285].Fix(BODY_FORCE_Y); -NODES[1285].Fix(BODY_FORCE_Z); -NODES[1286].Fix(BODY_FORCE_X); -NODES[1286].Fix(BODY_FORCE_Y); -NODES[1286].Fix(BODY_FORCE_Z); -NODES[1287].Fix(BODY_FORCE_X); -NODES[1287].Fix(BODY_FORCE_Y); -NODES[1287].Fix(BODY_FORCE_Z); -NODES[1288].Fix(BODY_FORCE_X); -NODES[1288].Fix(BODY_FORCE_Y); -NODES[1288].Fix(BODY_FORCE_Z); -NODES[1289].Fix(BODY_FORCE_X); -NODES[1289].Fix(BODY_FORCE_Y); -NODES[1289].Fix(BODY_FORCE_Z); -NODES[1290].Fix(BODY_FORCE_X); -NODES[1290].Fix(BODY_FORCE_Y); -NODES[1290].Fix(BODY_FORCE_Z); -NODES[1291].Fix(BODY_FORCE_X); -NODES[1291].Fix(BODY_FORCE_Y); -NODES[1291].Fix(BODY_FORCE_Z); -NODES[1292].Fix(BODY_FORCE_X); -NODES[1292].Fix(BODY_FORCE_Y); -NODES[1292].Fix(BODY_FORCE_Z); -NODES[1293].Fix(BODY_FORCE_X); -NODES[1293].Fix(BODY_FORCE_Y); -NODES[1293].Fix(BODY_FORCE_Z); -NODES[1294].Fix(BODY_FORCE_X); -NODES[1294].Fix(BODY_FORCE_Y); -NODES[1294].Fix(BODY_FORCE_Z); -NODES[1295].Fix(BODY_FORCE_X); -NODES[1295].Fix(BODY_FORCE_Y); -NODES[1295].Fix(BODY_FORCE_Z); -NODES[1296].Fix(BODY_FORCE_X); -NODES[1296].Fix(BODY_FORCE_Y); -NODES[1296].Fix(BODY_FORCE_Z); -NODES[1297].Fix(BODY_FORCE_X); -NODES[1297].Fix(BODY_FORCE_Y); -NODES[1297].Fix(BODY_FORCE_Z); -NODES[1298].Fix(BODY_FORCE_X); -NODES[1298].Fix(BODY_FORCE_Y); -NODES[1298].Fix(BODY_FORCE_Z); -NODES[1299].Fix(BODY_FORCE_X); -NODES[1299].Fix(BODY_FORCE_Y); -NODES[1299].Fix(BODY_FORCE_Z); -NODES[1300].Fix(BODY_FORCE_X); -NODES[1300].Fix(BODY_FORCE_Y); -NODES[1300].Fix(BODY_FORCE_Z); -NODES[1302].Fix(BODY_FORCE_X); -NODES[1302].Fix(BODY_FORCE_Y); -NODES[1302].Fix(BODY_FORCE_Z); -NODES[1303].Fix(BODY_FORCE_X); -NODES[1303].Fix(BODY_FORCE_Y); -NODES[1303].Fix(BODY_FORCE_Z); -NODES[1304].Fix(BODY_FORCE_X); -NODES[1304].Fix(BODY_FORCE_Y); -NODES[1304].Fix(BODY_FORCE_Z); -NODES[1305].Fix(BODY_FORCE_X); -NODES[1305].Fix(BODY_FORCE_Y); -NODES[1305].Fix(BODY_FORCE_Z); -NODES[1306].Fix(BODY_FORCE_X); -NODES[1306].Fix(BODY_FORCE_Y); -NODES[1306].Fix(BODY_FORCE_Z); -NODES[1307].Fix(BODY_FORCE_X); -NODES[1307].Fix(BODY_FORCE_Y); -NODES[1307].Fix(BODY_FORCE_Z); -NODES[1308].Fix(BODY_FORCE_X); -NODES[1308].Fix(BODY_FORCE_Y); -NODES[1308].Fix(BODY_FORCE_Z); -NODES[1309].Fix(BODY_FORCE_X); -NODES[1309].Fix(BODY_FORCE_Y); -NODES[1309].Fix(BODY_FORCE_Z); -NODES[1310].Fix(BODY_FORCE_X); -NODES[1310].Fix(BODY_FORCE_Y); -NODES[1310].Fix(BODY_FORCE_Z); -NODES[1311].Fix(BODY_FORCE_X); -NODES[1311].Fix(BODY_FORCE_Y); -NODES[1311].Fix(BODY_FORCE_Z); -NODES[1312].Fix(BODY_FORCE_X); -NODES[1312].Fix(BODY_FORCE_Y); -NODES[1312].Fix(BODY_FORCE_Z); -NODES[1313].Fix(BODY_FORCE_X); -NODES[1313].Fix(BODY_FORCE_Y); -NODES[1313].Fix(BODY_FORCE_Z); -NODES[1314].Fix(BODY_FORCE_X); -NODES[1314].Fix(BODY_FORCE_Y); -NODES[1314].Fix(BODY_FORCE_Z); -NODES[1315].Fix(BODY_FORCE_X); -NODES[1315].Fix(BODY_FORCE_Y); -NODES[1315].Fix(BODY_FORCE_Z); -NODES[1316].Fix(BODY_FORCE_X); -NODES[1316].Fix(BODY_FORCE_Y); -NODES[1316].Fix(BODY_FORCE_Z); -NODES[1317].Fix(BODY_FORCE_X); -NODES[1317].Fix(BODY_FORCE_Y); -NODES[1317].Fix(BODY_FORCE_Z); -NODES[1318].Fix(BODY_FORCE_X); -NODES[1318].Fix(BODY_FORCE_Y); -NODES[1318].Fix(BODY_FORCE_Z); -NODES[1319].Fix(BODY_FORCE_X); -NODES[1319].Fix(BODY_FORCE_Y); -NODES[1319].Fix(BODY_FORCE_Z); -NODES[1320].Fix(BODY_FORCE_X); -NODES[1320].Fix(BODY_FORCE_Y); -NODES[1320].Fix(BODY_FORCE_Z); -NODES[1321].Fix(BODY_FORCE_X); -NODES[1321].Fix(BODY_FORCE_Y); -NODES[1321].Fix(BODY_FORCE_Z); -NODES[1322].Fix(BODY_FORCE_X); -NODES[1322].Fix(BODY_FORCE_Y); -NODES[1322].Fix(BODY_FORCE_Z); -NODES[1323].Fix(BODY_FORCE_X); -NODES[1323].Fix(BODY_FORCE_Y); -NODES[1323].Fix(BODY_FORCE_Z); -NODES[1324].Fix(BODY_FORCE_X); -NODES[1324].Fix(BODY_FORCE_Y); -NODES[1324].Fix(BODY_FORCE_Z); -NODES[1325].Fix(BODY_FORCE_X); -NODES[1325].Fix(BODY_FORCE_Y); -NODES[1325].Fix(BODY_FORCE_Z); -NODES[1326].Fix(BODY_FORCE_X); -NODES[1326].Fix(BODY_FORCE_Y); -NODES[1326].Fix(BODY_FORCE_Z); -NODES[1327].Fix(BODY_FORCE_X); -NODES[1327].Fix(BODY_FORCE_Y); -NODES[1327].Fix(BODY_FORCE_Z); -NODES[1328].Fix(BODY_FORCE_X); -NODES[1328].Fix(BODY_FORCE_Y); -NODES[1328].Fix(BODY_FORCE_Z); -NODES[1329].Fix(BODY_FORCE_X); -NODES[1329].Fix(BODY_FORCE_Y); -NODES[1329].Fix(BODY_FORCE_Z); -NODES[1330].Fix(BODY_FORCE_X); -NODES[1330].Fix(BODY_FORCE_Y); -NODES[1330].Fix(BODY_FORCE_Z); -NODES[1331].Fix(BODY_FORCE_X); -NODES[1331].Fix(BODY_FORCE_Y); -NODES[1331].Fix(BODY_FORCE_Z); -NODES[1332].Fix(BODY_FORCE_X); -NODES[1332].Fix(BODY_FORCE_Y); -NODES[1332].Fix(BODY_FORCE_Z); -NODES[1333].Fix(BODY_FORCE_X); -NODES[1333].Fix(BODY_FORCE_Y); -NODES[1333].Fix(BODY_FORCE_Z); -NODES[1334].Fix(BODY_FORCE_X); -NODES[1334].Fix(BODY_FORCE_Y); -NODES[1334].Fix(BODY_FORCE_Z); -NODES[1335].Fix(BODY_FORCE_X); -NODES[1335].Fix(BODY_FORCE_Y); -NODES[1335].Fix(BODY_FORCE_Z); -NODES[1336].Fix(BODY_FORCE_X); -NODES[1336].Fix(BODY_FORCE_Y); -NODES[1336].Fix(BODY_FORCE_Z); -NODES[1337].Fix(BODY_FORCE_X); -NODES[1337].Fix(BODY_FORCE_Y); -NODES[1337].Fix(BODY_FORCE_Z); -NODES[1338].Fix(BODY_FORCE_X); -NODES[1338].Fix(BODY_FORCE_Y); -NODES[1338].Fix(BODY_FORCE_Z); -NODES[1339].Fix(BODY_FORCE_X); -NODES[1339].Fix(BODY_FORCE_Y); -NODES[1339].Fix(BODY_FORCE_Z); -NODES[1340].Fix(BODY_FORCE_X); -NODES[1340].Fix(BODY_FORCE_Y); -NODES[1340].Fix(BODY_FORCE_Z); -NODES[1341].Fix(BODY_FORCE_X); -NODES[1341].Fix(BODY_FORCE_Y); -NODES[1341].Fix(BODY_FORCE_Z); -NODES[1342].Fix(BODY_FORCE_X); -NODES[1342].Fix(BODY_FORCE_Y); -NODES[1342].Fix(BODY_FORCE_Z); -NODES[1343].Fix(BODY_FORCE_X); -NODES[1343].Fix(BODY_FORCE_Y); -NODES[1343].Fix(BODY_FORCE_Z); -NODES[1344].Fix(BODY_FORCE_X); -NODES[1344].Fix(BODY_FORCE_Y); -NODES[1344].Fix(BODY_FORCE_Z); -NODES[1345].Fix(BODY_FORCE_X); -NODES[1345].Fix(BODY_FORCE_Y); -NODES[1345].Fix(BODY_FORCE_Z); -NODES[1346].Fix(BODY_FORCE_X); -NODES[1346].Fix(BODY_FORCE_Y); -NODES[1346].Fix(BODY_FORCE_Z); -NODES[1347].Fix(BODY_FORCE_X); -NODES[1347].Fix(BODY_FORCE_Y); -NODES[1347].Fix(BODY_FORCE_Z); -NODES[1348].Fix(BODY_FORCE_X); -NODES[1348].Fix(BODY_FORCE_Y); -NODES[1348].Fix(BODY_FORCE_Z); -NODES[1350].Fix(BODY_FORCE_X); -NODES[1350].Fix(BODY_FORCE_Y); -NODES[1350].Fix(BODY_FORCE_Z); -NODES[1351].Fix(BODY_FORCE_X); -NODES[1351].Fix(BODY_FORCE_Y); -NODES[1351].Fix(BODY_FORCE_Z); -NODES[1352].Fix(BODY_FORCE_X); -NODES[1352].Fix(BODY_FORCE_Y); -NODES[1352].Fix(BODY_FORCE_Z); -NODES[1353].Fix(BODY_FORCE_X); -NODES[1353].Fix(BODY_FORCE_Y); -NODES[1353].Fix(BODY_FORCE_Z); -NODES[1354].Fix(BODY_FORCE_X); -NODES[1354].Fix(BODY_FORCE_Y); -NODES[1354].Fix(BODY_FORCE_Z); -NODES[1355].Fix(BODY_FORCE_X); -NODES[1355].Fix(BODY_FORCE_Y); -NODES[1355].Fix(BODY_FORCE_Z); -NODES[1356].Fix(BODY_FORCE_X); -NODES[1356].Fix(BODY_FORCE_Y); -NODES[1356].Fix(BODY_FORCE_Z); -NODES[1357].Fix(BODY_FORCE_X); -NODES[1357].Fix(BODY_FORCE_Y); -NODES[1357].Fix(BODY_FORCE_Z); -NODES[1358].Fix(BODY_FORCE_X); -NODES[1358].Fix(BODY_FORCE_Y); -NODES[1358].Fix(BODY_FORCE_Z); -NODES[1359].Fix(BODY_FORCE_X); -NODES[1359].Fix(BODY_FORCE_Y); -NODES[1359].Fix(BODY_FORCE_Z); -NODES[1360].Fix(BODY_FORCE_X); -NODES[1360].Fix(BODY_FORCE_Y); -NODES[1360].Fix(BODY_FORCE_Z); -NODES[1361].Fix(BODY_FORCE_X); -NODES[1361].Fix(BODY_FORCE_Y); -NODES[1361].Fix(BODY_FORCE_Z); -NODES[1362].Fix(BODY_FORCE_X); -NODES[1362].Fix(BODY_FORCE_Y); -NODES[1362].Fix(BODY_FORCE_Z); -NODES[1363].Fix(BODY_FORCE_X); -NODES[1363].Fix(BODY_FORCE_Y); -NODES[1363].Fix(BODY_FORCE_Z); -NODES[1364].Fix(BODY_FORCE_X); -NODES[1364].Fix(BODY_FORCE_Y); -NODES[1364].Fix(BODY_FORCE_Z); -NODES[1365].Fix(BODY_FORCE_X); -NODES[1365].Fix(BODY_FORCE_Y); -NODES[1365].Fix(BODY_FORCE_Z); -NODES[1366].Fix(BODY_FORCE_X); -NODES[1366].Fix(BODY_FORCE_Y); -NODES[1366].Fix(BODY_FORCE_Z); -NODES[1367].Fix(BODY_FORCE_X); -NODES[1367].Fix(BODY_FORCE_Y); -NODES[1367].Fix(BODY_FORCE_Z); -NODES[1368].Fix(BODY_FORCE_X); -NODES[1368].Fix(BODY_FORCE_Y); -NODES[1368].Fix(BODY_FORCE_Z); -NODES[1369].Fix(BODY_FORCE_X); -NODES[1369].Fix(BODY_FORCE_Y); -NODES[1369].Fix(BODY_FORCE_Z); -NODES[1370].Fix(BODY_FORCE_X); -NODES[1370].Fix(BODY_FORCE_Y); -NODES[1370].Fix(BODY_FORCE_Z); -NODES[1371].Fix(BODY_FORCE_X); -NODES[1371].Fix(BODY_FORCE_Y); -NODES[1371].Fix(BODY_FORCE_Z); -NODES[1372].Fix(BODY_FORCE_X); -NODES[1372].Fix(BODY_FORCE_Y); -NODES[1372].Fix(BODY_FORCE_Z); -NODES[1373].Fix(BODY_FORCE_X); -NODES[1373].Fix(BODY_FORCE_Y); -NODES[1373].Fix(BODY_FORCE_Z); -NODES[1374].Fix(BODY_FORCE_X); -NODES[1374].Fix(BODY_FORCE_Y); -NODES[1374].Fix(BODY_FORCE_Z); -NODES[1375].Fix(BODY_FORCE_X); -NODES[1375].Fix(BODY_FORCE_Y); -NODES[1375].Fix(BODY_FORCE_Z); -NODES[1376].Fix(BODY_FORCE_X); -NODES[1376].Fix(BODY_FORCE_Y); -NODES[1376].Fix(BODY_FORCE_Z); -NODES[1377].Fix(BODY_FORCE_X); -NODES[1377].Fix(BODY_FORCE_Y); -NODES[1377].Fix(BODY_FORCE_Z); -NODES[1378].Fix(BODY_FORCE_X); -NODES[1378].Fix(BODY_FORCE_Y); -NODES[1378].Fix(BODY_FORCE_Z); -NODES[1379].Fix(BODY_FORCE_X); -NODES[1379].Fix(BODY_FORCE_Y); -NODES[1379].Fix(BODY_FORCE_Z); -NODES[1380].Fix(BODY_FORCE_X); -NODES[1380].Fix(BODY_FORCE_Y); -NODES[1380].Fix(BODY_FORCE_Z); -NODES[1381].Fix(BODY_FORCE_X); -NODES[1381].Fix(BODY_FORCE_Y); -NODES[1381].Fix(BODY_FORCE_Z); -NODES[1382].Fix(BODY_FORCE_X); -NODES[1382].Fix(BODY_FORCE_Y); -NODES[1382].Fix(BODY_FORCE_Z); -NODES[1383].Fix(BODY_FORCE_X); -NODES[1383].Fix(BODY_FORCE_Y); -NODES[1383].Fix(BODY_FORCE_Z); -NODES[1384].Fix(BODY_FORCE_X); -NODES[1384].Fix(BODY_FORCE_Y); -NODES[1384].Fix(BODY_FORCE_Z); -NODES[1385].Fix(BODY_FORCE_X); -NODES[1385].Fix(BODY_FORCE_Y); -NODES[1385].Fix(BODY_FORCE_Z); -NODES[1386].Fix(BODY_FORCE_X); -NODES[1386].Fix(BODY_FORCE_Y); -NODES[1386].Fix(BODY_FORCE_Z); -NODES[1387].Fix(BODY_FORCE_X); -NODES[1387].Fix(BODY_FORCE_Y); -NODES[1387].Fix(BODY_FORCE_Z); -NODES[1388].Fix(BODY_FORCE_X); -NODES[1388].Fix(BODY_FORCE_Y); -NODES[1388].Fix(BODY_FORCE_Z); -NODES[1389].Fix(BODY_FORCE_X); -NODES[1389].Fix(BODY_FORCE_Y); -NODES[1389].Fix(BODY_FORCE_Z); -NODES[1390].Fix(BODY_FORCE_X); -NODES[1390].Fix(BODY_FORCE_Y); -NODES[1390].Fix(BODY_FORCE_Z); -NODES[1391].Fix(BODY_FORCE_X); -NODES[1391].Fix(BODY_FORCE_Y); -NODES[1391].Fix(BODY_FORCE_Z); -NODES[1392].Fix(BODY_FORCE_X); -NODES[1392].Fix(BODY_FORCE_Y); -NODES[1392].Fix(BODY_FORCE_Z); -NODES[1393].Fix(BODY_FORCE_X); -NODES[1393].Fix(BODY_FORCE_Y); -NODES[1393].Fix(BODY_FORCE_Z); -NODES[1394].Fix(BODY_FORCE_X); -NODES[1394].Fix(BODY_FORCE_Y); -NODES[1394].Fix(BODY_FORCE_Z); -NODES[1395].Fix(BODY_FORCE_X); -NODES[1395].Fix(BODY_FORCE_Y); -NODES[1395].Fix(BODY_FORCE_Z); -NODES[1397].Fix(BODY_FORCE_X); -NODES[1397].Fix(BODY_FORCE_Y); -NODES[1397].Fix(BODY_FORCE_Z); -NODES[1398].Fix(BODY_FORCE_X); -NODES[1398].Fix(BODY_FORCE_Y); -NODES[1398].Fix(BODY_FORCE_Z); -NODES[1399].Fix(BODY_FORCE_X); -NODES[1399].Fix(BODY_FORCE_Y); -NODES[1399].Fix(BODY_FORCE_Z); -NODES[1400].Fix(BODY_FORCE_X); -NODES[1400].Fix(BODY_FORCE_Y); -NODES[1400].Fix(BODY_FORCE_Z); -NODES[1401].Fix(BODY_FORCE_X); -NODES[1401].Fix(BODY_FORCE_Y); -NODES[1401].Fix(BODY_FORCE_Z); -NODES[1402].Fix(BODY_FORCE_X); -NODES[1402].Fix(BODY_FORCE_Y); -NODES[1402].Fix(BODY_FORCE_Z); -NODES[1403].Fix(BODY_FORCE_X); -NODES[1403].Fix(BODY_FORCE_Y); -NODES[1403].Fix(BODY_FORCE_Z); -NODES[1404].Fix(BODY_FORCE_X); -NODES[1404].Fix(BODY_FORCE_Y); -NODES[1404].Fix(BODY_FORCE_Z); -NODES[1405].Fix(BODY_FORCE_X); -NODES[1405].Fix(BODY_FORCE_Y); -NODES[1405].Fix(BODY_FORCE_Z); -NODES[1406].Fix(BODY_FORCE_X); -NODES[1406].Fix(BODY_FORCE_Y); -NODES[1406].Fix(BODY_FORCE_Z); -NODES[1407].Fix(BODY_FORCE_X); -NODES[1407].Fix(BODY_FORCE_Y); -NODES[1407].Fix(BODY_FORCE_Z); -NODES[1408].Fix(BODY_FORCE_X); -NODES[1408].Fix(BODY_FORCE_Y); -NODES[1408].Fix(BODY_FORCE_Z); -NODES[1409].Fix(BODY_FORCE_X); -NODES[1409].Fix(BODY_FORCE_Y); -NODES[1409].Fix(BODY_FORCE_Z); -NODES[1410].Fix(BODY_FORCE_X); -NODES[1410].Fix(BODY_FORCE_Y); -NODES[1410].Fix(BODY_FORCE_Z); -NODES[1411].Fix(BODY_FORCE_X); -NODES[1411].Fix(BODY_FORCE_Y); -NODES[1411].Fix(BODY_FORCE_Z); -NODES[1412].Fix(BODY_FORCE_X); -NODES[1412].Fix(BODY_FORCE_Y); -NODES[1412].Fix(BODY_FORCE_Z); -NODES[1413].Fix(BODY_FORCE_X); -NODES[1413].Fix(BODY_FORCE_Y); -NODES[1413].Fix(BODY_FORCE_Z); -NODES[1414].Fix(BODY_FORCE_X); -NODES[1414].Fix(BODY_FORCE_Y); -NODES[1414].Fix(BODY_FORCE_Z); -NODES[1415].Fix(BODY_FORCE_X); -NODES[1415].Fix(BODY_FORCE_Y); -NODES[1415].Fix(BODY_FORCE_Z); -NODES[1416].Fix(BODY_FORCE_X); -NODES[1416].Fix(BODY_FORCE_Y); -NODES[1416].Fix(BODY_FORCE_Z); -NODES[1417].Fix(BODY_FORCE_X); -NODES[1417].Fix(BODY_FORCE_Y); -NODES[1417].Fix(BODY_FORCE_Z); -NODES[1418].Fix(BODY_FORCE_X); -NODES[1418].Fix(BODY_FORCE_Y); -NODES[1418].Fix(BODY_FORCE_Z); -NODES[1419].Fix(BODY_FORCE_X); -NODES[1419].Fix(BODY_FORCE_Y); -NODES[1419].Fix(BODY_FORCE_Z); -NODES[1420].Fix(BODY_FORCE_X); -NODES[1420].Fix(BODY_FORCE_Y); -NODES[1420].Fix(BODY_FORCE_Z); -NODES[1421].Fix(BODY_FORCE_X); -NODES[1421].Fix(BODY_FORCE_Y); -NODES[1421].Fix(BODY_FORCE_Z); -NODES[1422].Fix(BODY_FORCE_X); -NODES[1422].Fix(BODY_FORCE_Y); -NODES[1422].Fix(BODY_FORCE_Z); -NODES[1423].Fix(BODY_FORCE_X); -NODES[1423].Fix(BODY_FORCE_Y); -NODES[1423].Fix(BODY_FORCE_Z); -NODES[1424].Fix(BODY_FORCE_X); -NODES[1424].Fix(BODY_FORCE_Y); -NODES[1424].Fix(BODY_FORCE_Z); -NODES[1425].Fix(BODY_FORCE_X); -NODES[1425].Fix(BODY_FORCE_Y); -NODES[1425].Fix(BODY_FORCE_Z); -NODES[1426].Fix(BODY_FORCE_X); -NODES[1426].Fix(BODY_FORCE_Y); -NODES[1426].Fix(BODY_FORCE_Z); -NODES[1427].Fix(BODY_FORCE_X); -NODES[1427].Fix(BODY_FORCE_Y); -NODES[1427].Fix(BODY_FORCE_Z); -NODES[1428].Fix(BODY_FORCE_X); -NODES[1428].Fix(BODY_FORCE_Y); -NODES[1428].Fix(BODY_FORCE_Z); -NODES[1429].Fix(BODY_FORCE_X); -NODES[1429].Fix(BODY_FORCE_Y); -NODES[1429].Fix(BODY_FORCE_Z); -NODES[1430].Fix(BODY_FORCE_X); -NODES[1430].Fix(BODY_FORCE_Y); -NODES[1430].Fix(BODY_FORCE_Z); -NODES[1431].Fix(BODY_FORCE_X); -NODES[1431].Fix(BODY_FORCE_Y); -NODES[1431].Fix(BODY_FORCE_Z); -NODES[1432].Fix(BODY_FORCE_X); -NODES[1432].Fix(BODY_FORCE_Y); -NODES[1432].Fix(BODY_FORCE_Z); -NODES[1433].Fix(BODY_FORCE_X); -NODES[1433].Fix(BODY_FORCE_Y); -NODES[1433].Fix(BODY_FORCE_Z); -NODES[1434].Fix(BODY_FORCE_X); -NODES[1434].Fix(BODY_FORCE_Y); -NODES[1434].Fix(BODY_FORCE_Z); -NODES[1435].Fix(BODY_FORCE_X); -NODES[1435].Fix(BODY_FORCE_Y); -NODES[1435].Fix(BODY_FORCE_Z); -NODES[1436].Fix(BODY_FORCE_X); -NODES[1436].Fix(BODY_FORCE_Y); -NODES[1436].Fix(BODY_FORCE_Z); -NODES[1437].Fix(BODY_FORCE_X); -NODES[1437].Fix(BODY_FORCE_Y); -NODES[1437].Fix(BODY_FORCE_Z); -NODES[1438].Fix(BODY_FORCE_X); -NODES[1438].Fix(BODY_FORCE_Y); -NODES[1438].Fix(BODY_FORCE_Z); -NODES[1439].Fix(BODY_FORCE_X); -NODES[1439].Fix(BODY_FORCE_Y); -NODES[1439].Fix(BODY_FORCE_Z); -NODES[1440].Fix(BODY_FORCE_X); -NODES[1440].Fix(BODY_FORCE_Y); -NODES[1440].Fix(BODY_FORCE_Z); -NODES[1442].Fix(BODY_FORCE_X); -NODES[1442].Fix(BODY_FORCE_Y); -NODES[1442].Fix(BODY_FORCE_Z); -NODES[1443].Fix(BODY_FORCE_X); -NODES[1443].Fix(BODY_FORCE_Y); -NODES[1443].Fix(BODY_FORCE_Z); -NODES[1444].Fix(BODY_FORCE_X); -NODES[1444].Fix(BODY_FORCE_Y); -NODES[1444].Fix(BODY_FORCE_Z); -NODES[1445].Fix(BODY_FORCE_X); -NODES[1445].Fix(BODY_FORCE_Y); -NODES[1445].Fix(BODY_FORCE_Z); -NODES[1446].Fix(BODY_FORCE_X); -NODES[1446].Fix(BODY_FORCE_Y); -NODES[1446].Fix(BODY_FORCE_Z); -NODES[1447].Fix(BODY_FORCE_X); -NODES[1447].Fix(BODY_FORCE_Y); -NODES[1447].Fix(BODY_FORCE_Z); -NODES[1448].Fix(BODY_FORCE_X); -NODES[1448].Fix(BODY_FORCE_Y); -NODES[1448].Fix(BODY_FORCE_Z); -NODES[1449].Fix(BODY_FORCE_X); -NODES[1449].Fix(BODY_FORCE_Y); -NODES[1449].Fix(BODY_FORCE_Z); -NODES[1450].Fix(BODY_FORCE_X); -NODES[1450].Fix(BODY_FORCE_Y); -NODES[1450].Fix(BODY_FORCE_Z); -NODES[1451].Fix(BODY_FORCE_X); -NODES[1451].Fix(BODY_FORCE_Y); -NODES[1451].Fix(BODY_FORCE_Z); -NODES[1452].Fix(BODY_FORCE_X); -NODES[1452].Fix(BODY_FORCE_Y); -NODES[1452].Fix(BODY_FORCE_Z); -NODES[1453].Fix(BODY_FORCE_X); -NODES[1453].Fix(BODY_FORCE_Y); -NODES[1453].Fix(BODY_FORCE_Z); -NODES[1454].Fix(BODY_FORCE_X); -NODES[1454].Fix(BODY_FORCE_Y); -NODES[1454].Fix(BODY_FORCE_Z); -NODES[1455].Fix(BODY_FORCE_X); -NODES[1455].Fix(BODY_FORCE_Y); -NODES[1455].Fix(BODY_FORCE_Z); -NODES[1456].Fix(BODY_FORCE_X); -NODES[1456].Fix(BODY_FORCE_Y); -NODES[1456].Fix(BODY_FORCE_Z); -NODES[1457].Fix(BODY_FORCE_X); -NODES[1457].Fix(BODY_FORCE_Y); -NODES[1457].Fix(BODY_FORCE_Z); -NODES[1458].Fix(BODY_FORCE_X); -NODES[1458].Fix(BODY_FORCE_Y); -NODES[1458].Fix(BODY_FORCE_Z); -NODES[1459].Fix(BODY_FORCE_X); -NODES[1459].Fix(BODY_FORCE_Y); -NODES[1459].Fix(BODY_FORCE_Z); -NODES[1460].Fix(BODY_FORCE_X); -NODES[1460].Fix(BODY_FORCE_Y); -NODES[1460].Fix(BODY_FORCE_Z); -NODES[1461].Fix(BODY_FORCE_X); -NODES[1461].Fix(BODY_FORCE_Y); -NODES[1461].Fix(BODY_FORCE_Z); -NODES[1462].Fix(BODY_FORCE_X); -NODES[1462].Fix(BODY_FORCE_Y); -NODES[1462].Fix(BODY_FORCE_Z); -NODES[1463].Fix(BODY_FORCE_X); -NODES[1463].Fix(BODY_FORCE_Y); -NODES[1463].Fix(BODY_FORCE_Z); -NODES[1464].Fix(BODY_FORCE_X); -NODES[1464].Fix(BODY_FORCE_Y); -NODES[1464].Fix(BODY_FORCE_Z); -NODES[1465].Fix(BODY_FORCE_X); -NODES[1465].Fix(BODY_FORCE_Y); -NODES[1465].Fix(BODY_FORCE_Z); -NODES[1466].Fix(BODY_FORCE_X); -NODES[1466].Fix(BODY_FORCE_Y); -NODES[1466].Fix(BODY_FORCE_Z); -NODES[1467].Fix(BODY_FORCE_X); -NODES[1467].Fix(BODY_FORCE_Y); -NODES[1467].Fix(BODY_FORCE_Z); -NODES[1468].Fix(BODY_FORCE_X); -NODES[1468].Fix(BODY_FORCE_Y); -NODES[1468].Fix(BODY_FORCE_Z); -NODES[1469].Fix(BODY_FORCE_X); -NODES[1469].Fix(BODY_FORCE_Y); -NODES[1469].Fix(BODY_FORCE_Z); -NODES[1470].Fix(BODY_FORCE_X); -NODES[1470].Fix(BODY_FORCE_Y); -NODES[1470].Fix(BODY_FORCE_Z); -NODES[1471].Fix(BODY_FORCE_X); -NODES[1471].Fix(BODY_FORCE_Y); -NODES[1471].Fix(BODY_FORCE_Z); -NODES[1472].Fix(BODY_FORCE_X); -NODES[1472].Fix(BODY_FORCE_Y); -NODES[1472].Fix(BODY_FORCE_Z); -NODES[1473].Fix(BODY_FORCE_X); -NODES[1473].Fix(BODY_FORCE_Y); -NODES[1473].Fix(BODY_FORCE_Z); -NODES[1474].Fix(BODY_FORCE_X); -NODES[1474].Fix(BODY_FORCE_Y); -NODES[1474].Fix(BODY_FORCE_Z); -NODES[1475].Fix(BODY_FORCE_X); -NODES[1475].Fix(BODY_FORCE_Y); -NODES[1475].Fix(BODY_FORCE_Z); -NODES[1476].Fix(BODY_FORCE_X); -NODES[1476].Fix(BODY_FORCE_Y); -NODES[1476].Fix(BODY_FORCE_Z); -NODES[1477].Fix(BODY_FORCE_X); -NODES[1477].Fix(BODY_FORCE_Y); -NODES[1477].Fix(BODY_FORCE_Z); -NODES[1478].Fix(BODY_FORCE_X); -NODES[1478].Fix(BODY_FORCE_Y); -NODES[1478].Fix(BODY_FORCE_Z); -NODES[1479].Fix(BODY_FORCE_X); -NODES[1479].Fix(BODY_FORCE_Y); -NODES[1479].Fix(BODY_FORCE_Z); -NODES[1480].Fix(BODY_FORCE_X); -NODES[1480].Fix(BODY_FORCE_Y); -NODES[1480].Fix(BODY_FORCE_Z); -NODES[1481].Fix(BODY_FORCE_X); -NODES[1481].Fix(BODY_FORCE_Y); -NODES[1481].Fix(BODY_FORCE_Z); -NODES[1482].Fix(BODY_FORCE_X); -NODES[1482].Fix(BODY_FORCE_Y); -NODES[1482].Fix(BODY_FORCE_Z); -NODES[1483].Fix(BODY_FORCE_X); -NODES[1483].Fix(BODY_FORCE_Y); -NODES[1483].Fix(BODY_FORCE_Z); -NODES[1484].Fix(BODY_FORCE_X); -NODES[1484].Fix(BODY_FORCE_Y); -NODES[1484].Fix(BODY_FORCE_Z); -NODES[1486].Fix(BODY_FORCE_X); -NODES[1486].Fix(BODY_FORCE_Y); -NODES[1486].Fix(BODY_FORCE_Z); -NODES[1487].Fix(BODY_FORCE_X); -NODES[1487].Fix(BODY_FORCE_Y); -NODES[1487].Fix(BODY_FORCE_Z); -NODES[1488].Fix(BODY_FORCE_X); -NODES[1488].Fix(BODY_FORCE_Y); -NODES[1488].Fix(BODY_FORCE_Z); -NODES[1489].Fix(BODY_FORCE_X); -NODES[1489].Fix(BODY_FORCE_Y); -NODES[1489].Fix(BODY_FORCE_Z); -NODES[1490].Fix(BODY_FORCE_X); -NODES[1490].Fix(BODY_FORCE_Y); -NODES[1490].Fix(BODY_FORCE_Z); -NODES[1491].Fix(BODY_FORCE_X); -NODES[1491].Fix(BODY_FORCE_Y); -NODES[1491].Fix(BODY_FORCE_Z); -NODES[1492].Fix(BODY_FORCE_X); -NODES[1492].Fix(BODY_FORCE_Y); -NODES[1492].Fix(BODY_FORCE_Z); -NODES[1493].Fix(BODY_FORCE_X); -NODES[1493].Fix(BODY_FORCE_Y); -NODES[1493].Fix(BODY_FORCE_Z); -NODES[1494].Fix(BODY_FORCE_X); -NODES[1494].Fix(BODY_FORCE_Y); -NODES[1494].Fix(BODY_FORCE_Z); -NODES[1495].Fix(BODY_FORCE_X); -NODES[1495].Fix(BODY_FORCE_Y); -NODES[1495].Fix(BODY_FORCE_Z); -NODES[1496].Fix(BODY_FORCE_X); -NODES[1496].Fix(BODY_FORCE_Y); -NODES[1496].Fix(BODY_FORCE_Z); -NODES[1497].Fix(BODY_FORCE_X); -NODES[1497].Fix(BODY_FORCE_Y); -NODES[1497].Fix(BODY_FORCE_Z); -NODES[1498].Fix(BODY_FORCE_X); -NODES[1498].Fix(BODY_FORCE_Y); -NODES[1498].Fix(BODY_FORCE_Z); -NODES[1499].Fix(BODY_FORCE_X); -NODES[1499].Fix(BODY_FORCE_Y); -NODES[1499].Fix(BODY_FORCE_Z); -NODES[1500].Fix(BODY_FORCE_X); -NODES[1500].Fix(BODY_FORCE_Y); -NODES[1500].Fix(BODY_FORCE_Z); -NODES[1501].Fix(BODY_FORCE_X); -NODES[1501].Fix(BODY_FORCE_Y); -NODES[1501].Fix(BODY_FORCE_Z); -NODES[1502].Fix(BODY_FORCE_X); -NODES[1502].Fix(BODY_FORCE_Y); -NODES[1502].Fix(BODY_FORCE_Z); -NODES[1503].Fix(BODY_FORCE_X); -NODES[1503].Fix(BODY_FORCE_Y); -NODES[1503].Fix(BODY_FORCE_Z); -NODES[1504].Fix(BODY_FORCE_X); -NODES[1504].Fix(BODY_FORCE_Y); -NODES[1504].Fix(BODY_FORCE_Z); -NODES[1505].Fix(BODY_FORCE_X); -NODES[1505].Fix(BODY_FORCE_Y); -NODES[1505].Fix(BODY_FORCE_Z); -NODES[1506].Fix(BODY_FORCE_X); -NODES[1506].Fix(BODY_FORCE_Y); -NODES[1506].Fix(BODY_FORCE_Z); -NODES[1507].Fix(BODY_FORCE_X); -NODES[1507].Fix(BODY_FORCE_Y); -NODES[1507].Fix(BODY_FORCE_Z); -NODES[1508].Fix(BODY_FORCE_X); -NODES[1508].Fix(BODY_FORCE_Y); -NODES[1508].Fix(BODY_FORCE_Z); -NODES[1509].Fix(BODY_FORCE_X); -NODES[1509].Fix(BODY_FORCE_Y); -NODES[1509].Fix(BODY_FORCE_Z); -NODES[1510].Fix(BODY_FORCE_X); -NODES[1510].Fix(BODY_FORCE_Y); -NODES[1510].Fix(BODY_FORCE_Z); -NODES[1511].Fix(BODY_FORCE_X); -NODES[1511].Fix(BODY_FORCE_Y); -NODES[1511].Fix(BODY_FORCE_Z); -NODES[1512].Fix(BODY_FORCE_X); -NODES[1512].Fix(BODY_FORCE_Y); -NODES[1512].Fix(BODY_FORCE_Z); -NODES[1513].Fix(BODY_FORCE_X); -NODES[1513].Fix(BODY_FORCE_Y); -NODES[1513].Fix(BODY_FORCE_Z); -NODES[1514].Fix(BODY_FORCE_X); -NODES[1514].Fix(BODY_FORCE_Y); -NODES[1514].Fix(BODY_FORCE_Z); -NODES[1515].Fix(BODY_FORCE_X); -NODES[1515].Fix(BODY_FORCE_Y); -NODES[1515].Fix(BODY_FORCE_Z); -NODES[1516].Fix(BODY_FORCE_X); -NODES[1516].Fix(BODY_FORCE_Y); -NODES[1516].Fix(BODY_FORCE_Z); -NODES[1517].Fix(BODY_FORCE_X); -NODES[1517].Fix(BODY_FORCE_Y); -NODES[1517].Fix(BODY_FORCE_Z); -NODES[1518].Fix(BODY_FORCE_X); -NODES[1518].Fix(BODY_FORCE_Y); -NODES[1518].Fix(BODY_FORCE_Z); -NODES[1519].Fix(BODY_FORCE_X); -NODES[1519].Fix(BODY_FORCE_Y); -NODES[1519].Fix(BODY_FORCE_Z); -NODES[1520].Fix(BODY_FORCE_X); -NODES[1520].Fix(BODY_FORCE_Y); -NODES[1520].Fix(BODY_FORCE_Z); -NODES[1521].Fix(BODY_FORCE_X); -NODES[1521].Fix(BODY_FORCE_Y); -NODES[1521].Fix(BODY_FORCE_Z); -NODES[1522].Fix(BODY_FORCE_X); -NODES[1522].Fix(BODY_FORCE_Y); -NODES[1522].Fix(BODY_FORCE_Z); -NODES[1523].Fix(BODY_FORCE_X); -NODES[1523].Fix(BODY_FORCE_Y); -NODES[1523].Fix(BODY_FORCE_Z); -NODES[1524].Fix(BODY_FORCE_X); -NODES[1524].Fix(BODY_FORCE_Y); -NODES[1524].Fix(BODY_FORCE_Z); -NODES[1525].Fix(BODY_FORCE_X); -NODES[1525].Fix(BODY_FORCE_Y); -NODES[1525].Fix(BODY_FORCE_Z); -NODES[1526].Fix(BODY_FORCE_X); -NODES[1526].Fix(BODY_FORCE_Y); -NODES[1526].Fix(BODY_FORCE_Z); -NODES[1528].Fix(BODY_FORCE_X); -NODES[1528].Fix(BODY_FORCE_Y); -NODES[1528].Fix(BODY_FORCE_Z); -NODES[1529].Fix(BODY_FORCE_X); -NODES[1529].Fix(BODY_FORCE_Y); -NODES[1529].Fix(BODY_FORCE_Z); -NODES[1530].Fix(BODY_FORCE_X); -NODES[1530].Fix(BODY_FORCE_Y); -NODES[1530].Fix(BODY_FORCE_Z); -NODES[1531].Fix(BODY_FORCE_X); -NODES[1531].Fix(BODY_FORCE_Y); -NODES[1531].Fix(BODY_FORCE_Z); -NODES[1532].Fix(BODY_FORCE_X); -NODES[1532].Fix(BODY_FORCE_Y); -NODES[1532].Fix(BODY_FORCE_Z); -NODES[1533].Fix(BODY_FORCE_X); -NODES[1533].Fix(BODY_FORCE_Y); -NODES[1533].Fix(BODY_FORCE_Z); -NODES[1534].Fix(BODY_FORCE_X); -NODES[1534].Fix(BODY_FORCE_Y); -NODES[1534].Fix(BODY_FORCE_Z); -NODES[1535].Fix(BODY_FORCE_X); -NODES[1535].Fix(BODY_FORCE_Y); -NODES[1535].Fix(BODY_FORCE_Z); -NODES[1536].Fix(BODY_FORCE_X); -NODES[1536].Fix(BODY_FORCE_Y); -NODES[1536].Fix(BODY_FORCE_Z); -NODES[1537].Fix(BODY_FORCE_X); -NODES[1537].Fix(BODY_FORCE_Y); -NODES[1537].Fix(BODY_FORCE_Z); -NODES[1538].Fix(BODY_FORCE_X); -NODES[1538].Fix(BODY_FORCE_Y); -NODES[1538].Fix(BODY_FORCE_Z); -NODES[1539].Fix(BODY_FORCE_X); -NODES[1539].Fix(BODY_FORCE_Y); -NODES[1539].Fix(BODY_FORCE_Z); -NODES[1540].Fix(BODY_FORCE_X); -NODES[1540].Fix(BODY_FORCE_Y); -NODES[1540].Fix(BODY_FORCE_Z); -NODES[1541].Fix(BODY_FORCE_X); -NODES[1541].Fix(BODY_FORCE_Y); -NODES[1541].Fix(BODY_FORCE_Z); -NODES[1542].Fix(BODY_FORCE_X); -NODES[1542].Fix(BODY_FORCE_Y); -NODES[1542].Fix(BODY_FORCE_Z); -NODES[1543].Fix(BODY_FORCE_X); -NODES[1543].Fix(BODY_FORCE_Y); -NODES[1543].Fix(BODY_FORCE_Z); -NODES[1544].Fix(BODY_FORCE_X); -NODES[1544].Fix(BODY_FORCE_Y); -NODES[1544].Fix(BODY_FORCE_Z); -NODES[1545].Fix(BODY_FORCE_X); -NODES[1545].Fix(BODY_FORCE_Y); -NODES[1545].Fix(BODY_FORCE_Z); -NODES[1546].Fix(BODY_FORCE_X); -NODES[1546].Fix(BODY_FORCE_Y); -NODES[1546].Fix(BODY_FORCE_Z); -NODES[1547].Fix(BODY_FORCE_X); -NODES[1547].Fix(BODY_FORCE_Y); -NODES[1547].Fix(BODY_FORCE_Z); -NODES[1548].Fix(BODY_FORCE_X); -NODES[1548].Fix(BODY_FORCE_Y); -NODES[1548].Fix(BODY_FORCE_Z); -NODES[1549].Fix(BODY_FORCE_X); -NODES[1549].Fix(BODY_FORCE_Y); -NODES[1549].Fix(BODY_FORCE_Z); -NODES[1550].Fix(BODY_FORCE_X); -NODES[1550].Fix(BODY_FORCE_Y); -NODES[1550].Fix(BODY_FORCE_Z); -NODES[1551].Fix(BODY_FORCE_X); -NODES[1551].Fix(BODY_FORCE_Y); -NODES[1551].Fix(BODY_FORCE_Z); -NODES[1552].Fix(BODY_FORCE_X); -NODES[1552].Fix(BODY_FORCE_Y); -NODES[1552].Fix(BODY_FORCE_Z); -NODES[1553].Fix(BODY_FORCE_X); -NODES[1553].Fix(BODY_FORCE_Y); -NODES[1553].Fix(BODY_FORCE_Z); -NODES[1554].Fix(BODY_FORCE_X); -NODES[1554].Fix(BODY_FORCE_Y); -NODES[1554].Fix(BODY_FORCE_Z); -NODES[1555].Fix(BODY_FORCE_X); -NODES[1555].Fix(BODY_FORCE_Y); -NODES[1555].Fix(BODY_FORCE_Z); -NODES[1556].Fix(BODY_FORCE_X); -NODES[1556].Fix(BODY_FORCE_Y); -NODES[1556].Fix(BODY_FORCE_Z); -NODES[1557].Fix(BODY_FORCE_X); -NODES[1557].Fix(BODY_FORCE_Y); -NODES[1557].Fix(BODY_FORCE_Z); -NODES[1558].Fix(BODY_FORCE_X); -NODES[1558].Fix(BODY_FORCE_Y); -NODES[1558].Fix(BODY_FORCE_Z); -NODES[1559].Fix(BODY_FORCE_X); -NODES[1559].Fix(BODY_FORCE_Y); -NODES[1559].Fix(BODY_FORCE_Z); -NODES[1560].Fix(BODY_FORCE_X); -NODES[1560].Fix(BODY_FORCE_Y); -NODES[1560].Fix(BODY_FORCE_Z); -NODES[1561].Fix(BODY_FORCE_X); -NODES[1561].Fix(BODY_FORCE_Y); -NODES[1561].Fix(BODY_FORCE_Z); -NODES[1562].Fix(BODY_FORCE_X); -NODES[1562].Fix(BODY_FORCE_Y); -NODES[1562].Fix(BODY_FORCE_Z); -NODES[1563].Fix(BODY_FORCE_X); -NODES[1563].Fix(BODY_FORCE_Y); -NODES[1563].Fix(BODY_FORCE_Z); -NODES[1564].Fix(BODY_FORCE_X); -NODES[1564].Fix(BODY_FORCE_Y); -NODES[1564].Fix(BODY_FORCE_Z); -NODES[1565].Fix(BODY_FORCE_X); -NODES[1565].Fix(BODY_FORCE_Y); -NODES[1565].Fix(BODY_FORCE_Z); -NODES[1566].Fix(BODY_FORCE_X); -NODES[1566].Fix(BODY_FORCE_Y); -NODES[1566].Fix(BODY_FORCE_Z); -NODES[1567].Fix(BODY_FORCE_X); -NODES[1567].Fix(BODY_FORCE_Y); -NODES[1567].Fix(BODY_FORCE_Z); -NODES[1568].Fix(BODY_FORCE_X); -NODES[1568].Fix(BODY_FORCE_Y); -NODES[1568].Fix(BODY_FORCE_Z); -NODES[1569].Fix(BODY_FORCE_X); -NODES[1569].Fix(BODY_FORCE_Y); -NODES[1569].Fix(BODY_FORCE_Z); -NODES[1570].Fix(BODY_FORCE_X); -NODES[1570].Fix(BODY_FORCE_Y); -NODES[1570].Fix(BODY_FORCE_Z); -NODES[1572].Fix(BODY_FORCE_X); -NODES[1572].Fix(BODY_FORCE_Y); -NODES[1572].Fix(BODY_FORCE_Z); -NODES[1573].Fix(BODY_FORCE_X); -NODES[1573].Fix(BODY_FORCE_Y); -NODES[1573].Fix(BODY_FORCE_Z); -NODES[1574].Fix(BODY_FORCE_X); -NODES[1574].Fix(BODY_FORCE_Y); -NODES[1574].Fix(BODY_FORCE_Z); -NODES[1575].Fix(BODY_FORCE_X); -NODES[1575].Fix(BODY_FORCE_Y); -NODES[1575].Fix(BODY_FORCE_Z); -NODES[1576].Fix(BODY_FORCE_X); -NODES[1576].Fix(BODY_FORCE_Y); -NODES[1576].Fix(BODY_FORCE_Z); -NODES[1577].Fix(BODY_FORCE_X); -NODES[1577].Fix(BODY_FORCE_Y); -NODES[1577].Fix(BODY_FORCE_Z); -NODES[1578].Fix(BODY_FORCE_X); -NODES[1578].Fix(BODY_FORCE_Y); -NODES[1578].Fix(BODY_FORCE_Z); -NODES[1579].Fix(BODY_FORCE_X); -NODES[1579].Fix(BODY_FORCE_Y); -NODES[1579].Fix(BODY_FORCE_Z); -NODES[1580].Fix(BODY_FORCE_X); -NODES[1580].Fix(BODY_FORCE_Y); -NODES[1580].Fix(BODY_FORCE_Z); -NODES[1581].Fix(BODY_FORCE_X); -NODES[1581].Fix(BODY_FORCE_Y); -NODES[1581].Fix(BODY_FORCE_Z); -NODES[1582].Fix(BODY_FORCE_X); -NODES[1582].Fix(BODY_FORCE_Y); -NODES[1582].Fix(BODY_FORCE_Z); -NODES[1583].Fix(BODY_FORCE_X); -NODES[1583].Fix(BODY_FORCE_Y); -NODES[1583].Fix(BODY_FORCE_Z); -NODES[1584].Fix(BODY_FORCE_X); -NODES[1584].Fix(BODY_FORCE_Y); -NODES[1584].Fix(BODY_FORCE_Z); -NODES[1585].Fix(BODY_FORCE_X); -NODES[1585].Fix(BODY_FORCE_Y); -NODES[1585].Fix(BODY_FORCE_Z); -NODES[1586].Fix(BODY_FORCE_X); -NODES[1586].Fix(BODY_FORCE_Y); -NODES[1586].Fix(BODY_FORCE_Z); -NODES[1587].Fix(BODY_FORCE_X); -NODES[1587].Fix(BODY_FORCE_Y); -NODES[1587].Fix(BODY_FORCE_Z); -NODES[1588].Fix(BODY_FORCE_X); -NODES[1588].Fix(BODY_FORCE_Y); -NODES[1588].Fix(BODY_FORCE_Z); -NODES[1589].Fix(BODY_FORCE_X); -NODES[1589].Fix(BODY_FORCE_Y); -NODES[1589].Fix(BODY_FORCE_Z); -NODES[1590].Fix(BODY_FORCE_X); -NODES[1590].Fix(BODY_FORCE_Y); -NODES[1590].Fix(BODY_FORCE_Z); -NODES[1591].Fix(BODY_FORCE_X); -NODES[1591].Fix(BODY_FORCE_Y); -NODES[1591].Fix(BODY_FORCE_Z); -NODES[1592].Fix(BODY_FORCE_X); -NODES[1592].Fix(BODY_FORCE_Y); -NODES[1592].Fix(BODY_FORCE_Z); -NODES[1593].Fix(BODY_FORCE_X); -NODES[1593].Fix(BODY_FORCE_Y); -NODES[1593].Fix(BODY_FORCE_Z); -NODES[1594].Fix(BODY_FORCE_X); -NODES[1594].Fix(BODY_FORCE_Y); -NODES[1594].Fix(BODY_FORCE_Z); -NODES[1595].Fix(BODY_FORCE_X); -NODES[1595].Fix(BODY_FORCE_Y); -NODES[1595].Fix(BODY_FORCE_Z); -NODES[1596].Fix(BODY_FORCE_X); -NODES[1596].Fix(BODY_FORCE_Y); -NODES[1596].Fix(BODY_FORCE_Z); -NODES[1597].Fix(BODY_FORCE_X); -NODES[1597].Fix(BODY_FORCE_Y); -NODES[1597].Fix(BODY_FORCE_Z); -NODES[1598].Fix(BODY_FORCE_X); -NODES[1598].Fix(BODY_FORCE_Y); -NODES[1598].Fix(BODY_FORCE_Z); -NODES[1599].Fix(BODY_FORCE_X); -NODES[1599].Fix(BODY_FORCE_Y); -NODES[1599].Fix(BODY_FORCE_Z); -NODES[1600].Fix(BODY_FORCE_X); -NODES[1600].Fix(BODY_FORCE_Y); -NODES[1600].Fix(BODY_FORCE_Z); -NODES[1601].Fix(BODY_FORCE_X); -NODES[1601].Fix(BODY_FORCE_Y); -NODES[1601].Fix(BODY_FORCE_Z); -NODES[1602].Fix(BODY_FORCE_X); -NODES[1602].Fix(BODY_FORCE_Y); -NODES[1602].Fix(BODY_FORCE_Z); -NODES[1603].Fix(BODY_FORCE_X); -NODES[1603].Fix(BODY_FORCE_Y); -NODES[1603].Fix(BODY_FORCE_Z); -NODES[1604].Fix(BODY_FORCE_X); -NODES[1604].Fix(BODY_FORCE_Y); -NODES[1604].Fix(BODY_FORCE_Z); -NODES[1605].Fix(BODY_FORCE_X); -NODES[1605].Fix(BODY_FORCE_Y); -NODES[1605].Fix(BODY_FORCE_Z); -NODES[1606].Fix(BODY_FORCE_X); -NODES[1606].Fix(BODY_FORCE_Y); -NODES[1606].Fix(BODY_FORCE_Z); -NODES[1607].Fix(BODY_FORCE_X); -NODES[1607].Fix(BODY_FORCE_Y); -NODES[1607].Fix(BODY_FORCE_Z); -NODES[1608].Fix(BODY_FORCE_X); -NODES[1608].Fix(BODY_FORCE_Y); -NODES[1608].Fix(BODY_FORCE_Z); -NODES[1609].Fix(BODY_FORCE_X); -NODES[1609].Fix(BODY_FORCE_Y); -NODES[1609].Fix(BODY_FORCE_Z); -NODES[1610].Fix(BODY_FORCE_X); -NODES[1610].Fix(BODY_FORCE_Y); -NODES[1610].Fix(BODY_FORCE_Z); -NODES[1612].Fix(BODY_FORCE_X); -NODES[1612].Fix(BODY_FORCE_Y); -NODES[1612].Fix(BODY_FORCE_Z); -NODES[1613].Fix(BODY_FORCE_X); -NODES[1613].Fix(BODY_FORCE_Y); -NODES[1613].Fix(BODY_FORCE_Z); -NODES[1614].Fix(BODY_FORCE_X); -NODES[1614].Fix(BODY_FORCE_Y); -NODES[1614].Fix(BODY_FORCE_Z); -NODES[1615].Fix(BODY_FORCE_X); -NODES[1615].Fix(BODY_FORCE_Y); -NODES[1615].Fix(BODY_FORCE_Z); -NODES[1616].Fix(BODY_FORCE_X); -NODES[1616].Fix(BODY_FORCE_Y); -NODES[1616].Fix(BODY_FORCE_Z); -NODES[1617].Fix(BODY_FORCE_X); -NODES[1617].Fix(BODY_FORCE_Y); -NODES[1617].Fix(BODY_FORCE_Z); -NODES[1618].Fix(BODY_FORCE_X); -NODES[1618].Fix(BODY_FORCE_Y); -NODES[1618].Fix(BODY_FORCE_Z); -NODES[1619].Fix(BODY_FORCE_X); -NODES[1619].Fix(BODY_FORCE_Y); -NODES[1619].Fix(BODY_FORCE_Z); -NODES[1620].Fix(BODY_FORCE_X); -NODES[1620].Fix(BODY_FORCE_Y); -NODES[1620].Fix(BODY_FORCE_Z); -NODES[1621].Fix(BODY_FORCE_X); -NODES[1621].Fix(BODY_FORCE_Y); -NODES[1621].Fix(BODY_FORCE_Z); -NODES[1622].Fix(BODY_FORCE_X); -NODES[1622].Fix(BODY_FORCE_Y); -NODES[1622].Fix(BODY_FORCE_Z); -NODES[1623].Fix(BODY_FORCE_X); -NODES[1623].Fix(BODY_FORCE_Y); -NODES[1623].Fix(BODY_FORCE_Z); -NODES[1624].Fix(BODY_FORCE_X); -NODES[1624].Fix(BODY_FORCE_Y); -NODES[1624].Fix(BODY_FORCE_Z); -NODES[1625].Fix(BODY_FORCE_X); -NODES[1625].Fix(BODY_FORCE_Y); -NODES[1625].Fix(BODY_FORCE_Z); -NODES[1626].Fix(BODY_FORCE_X); -NODES[1626].Fix(BODY_FORCE_Y); -NODES[1626].Fix(BODY_FORCE_Z); -NODES[1627].Fix(BODY_FORCE_X); -NODES[1627].Fix(BODY_FORCE_Y); -NODES[1627].Fix(BODY_FORCE_Z); -NODES[1628].Fix(BODY_FORCE_X); -NODES[1628].Fix(BODY_FORCE_Y); -NODES[1628].Fix(BODY_FORCE_Z); -NODES[1629].Fix(BODY_FORCE_X); -NODES[1629].Fix(BODY_FORCE_Y); -NODES[1629].Fix(BODY_FORCE_Z); -NODES[1630].Fix(BODY_FORCE_X); -NODES[1630].Fix(BODY_FORCE_Y); -NODES[1630].Fix(BODY_FORCE_Z); -NODES[1631].Fix(BODY_FORCE_X); -NODES[1631].Fix(BODY_FORCE_Y); -NODES[1631].Fix(BODY_FORCE_Z); -NODES[1632].Fix(BODY_FORCE_X); -NODES[1632].Fix(BODY_FORCE_Y); -NODES[1632].Fix(BODY_FORCE_Z); -NODES[1633].Fix(BODY_FORCE_X); -NODES[1633].Fix(BODY_FORCE_Y); -NODES[1633].Fix(BODY_FORCE_Z); -NODES[1634].Fix(BODY_FORCE_X); -NODES[1634].Fix(BODY_FORCE_Y); -NODES[1634].Fix(BODY_FORCE_Z); -NODES[1635].Fix(BODY_FORCE_X); -NODES[1635].Fix(BODY_FORCE_Y); -NODES[1635].Fix(BODY_FORCE_Z); -NODES[1636].Fix(BODY_FORCE_X); -NODES[1636].Fix(BODY_FORCE_Y); -NODES[1636].Fix(BODY_FORCE_Z); -NODES[1637].Fix(BODY_FORCE_X); -NODES[1637].Fix(BODY_FORCE_Y); -NODES[1637].Fix(BODY_FORCE_Z); -NODES[1638].Fix(BODY_FORCE_X); -NODES[1638].Fix(BODY_FORCE_Y); -NODES[1638].Fix(BODY_FORCE_Z); -NODES[1639].Fix(BODY_FORCE_X); -NODES[1639].Fix(BODY_FORCE_Y); -NODES[1639].Fix(BODY_FORCE_Z); -NODES[1640].Fix(BODY_FORCE_X); -NODES[1640].Fix(BODY_FORCE_Y); -NODES[1640].Fix(BODY_FORCE_Z); -NODES[1641].Fix(BODY_FORCE_X); -NODES[1641].Fix(BODY_FORCE_Y); -NODES[1641].Fix(BODY_FORCE_Z); -NODES[1642].Fix(BODY_FORCE_X); -NODES[1642].Fix(BODY_FORCE_Y); -NODES[1642].Fix(BODY_FORCE_Z); -NODES[1643].Fix(BODY_FORCE_X); -NODES[1643].Fix(BODY_FORCE_Y); -NODES[1643].Fix(BODY_FORCE_Z); -NODES[1644].Fix(BODY_FORCE_X); -NODES[1644].Fix(BODY_FORCE_Y); -NODES[1644].Fix(BODY_FORCE_Z); -NODES[1645].Fix(BODY_FORCE_X); -NODES[1645].Fix(BODY_FORCE_Y); -NODES[1645].Fix(BODY_FORCE_Z); -NODES[1646].Fix(BODY_FORCE_X); -NODES[1646].Fix(BODY_FORCE_Y); -NODES[1646].Fix(BODY_FORCE_Z); -NODES[1647].Fix(BODY_FORCE_X); -NODES[1647].Fix(BODY_FORCE_Y); -NODES[1647].Fix(BODY_FORCE_Z); -NODES[1648].Fix(BODY_FORCE_X); -NODES[1648].Fix(BODY_FORCE_Y); -NODES[1648].Fix(BODY_FORCE_Z); -NODES[1649].Fix(BODY_FORCE_X); -NODES[1649].Fix(BODY_FORCE_Y); -NODES[1649].Fix(BODY_FORCE_Z); -NODES[1650].Fix(BODY_FORCE_X); -NODES[1650].Fix(BODY_FORCE_Y); -NODES[1650].Fix(BODY_FORCE_Z); -NODES[1652].Fix(BODY_FORCE_X); -NODES[1652].Fix(BODY_FORCE_Y); -NODES[1652].Fix(BODY_FORCE_Z); -NODES[1653].Fix(BODY_FORCE_X); -NODES[1653].Fix(BODY_FORCE_Y); -NODES[1653].Fix(BODY_FORCE_Z); -NODES[1654].Fix(BODY_FORCE_X); -NODES[1654].Fix(BODY_FORCE_Y); -NODES[1654].Fix(BODY_FORCE_Z); -NODES[1655].Fix(BODY_FORCE_X); -NODES[1655].Fix(BODY_FORCE_Y); -NODES[1655].Fix(BODY_FORCE_Z); -NODES[1656].Fix(BODY_FORCE_X); -NODES[1656].Fix(BODY_FORCE_Y); -NODES[1656].Fix(BODY_FORCE_Z); -NODES[1657].Fix(BODY_FORCE_X); -NODES[1657].Fix(BODY_FORCE_Y); -NODES[1657].Fix(BODY_FORCE_Z); -NODES[1658].Fix(BODY_FORCE_X); -NODES[1658].Fix(BODY_FORCE_Y); -NODES[1658].Fix(BODY_FORCE_Z); -NODES[1659].Fix(BODY_FORCE_X); -NODES[1659].Fix(BODY_FORCE_Y); -NODES[1659].Fix(BODY_FORCE_Z); -NODES[1660].Fix(BODY_FORCE_X); -NODES[1660].Fix(BODY_FORCE_Y); -NODES[1660].Fix(BODY_FORCE_Z); -NODES[1661].Fix(BODY_FORCE_X); -NODES[1661].Fix(BODY_FORCE_Y); -NODES[1661].Fix(BODY_FORCE_Z); -NODES[1662].Fix(BODY_FORCE_X); -NODES[1662].Fix(BODY_FORCE_Y); -NODES[1662].Fix(BODY_FORCE_Z); -NODES[1663].Fix(BODY_FORCE_X); -NODES[1663].Fix(BODY_FORCE_Y); -NODES[1663].Fix(BODY_FORCE_Z); -NODES[1664].Fix(BODY_FORCE_X); -NODES[1664].Fix(BODY_FORCE_Y); -NODES[1664].Fix(BODY_FORCE_Z); -NODES[1665].Fix(BODY_FORCE_X); -NODES[1665].Fix(BODY_FORCE_Y); -NODES[1665].Fix(BODY_FORCE_Z); -NODES[1666].Fix(BODY_FORCE_X); -NODES[1666].Fix(BODY_FORCE_Y); -NODES[1666].Fix(BODY_FORCE_Z); -NODES[1667].Fix(BODY_FORCE_X); -NODES[1667].Fix(BODY_FORCE_Y); -NODES[1667].Fix(BODY_FORCE_Z); -NODES[1668].Fix(BODY_FORCE_X); -NODES[1668].Fix(BODY_FORCE_Y); -NODES[1668].Fix(BODY_FORCE_Z); -NODES[1669].Fix(BODY_FORCE_X); -NODES[1669].Fix(BODY_FORCE_Y); -NODES[1669].Fix(BODY_FORCE_Z); -NODES[1670].Fix(BODY_FORCE_X); -NODES[1670].Fix(BODY_FORCE_Y); -NODES[1670].Fix(BODY_FORCE_Z); -NODES[1671].Fix(BODY_FORCE_X); -NODES[1671].Fix(BODY_FORCE_Y); -NODES[1671].Fix(BODY_FORCE_Z); -NODES[1672].Fix(BODY_FORCE_X); -NODES[1672].Fix(BODY_FORCE_Y); -NODES[1672].Fix(BODY_FORCE_Z); -NODES[1673].Fix(BODY_FORCE_X); -NODES[1673].Fix(BODY_FORCE_Y); -NODES[1673].Fix(BODY_FORCE_Z); -NODES[1674].Fix(BODY_FORCE_X); -NODES[1674].Fix(BODY_FORCE_Y); -NODES[1674].Fix(BODY_FORCE_Z); -NODES[1675].Fix(BODY_FORCE_X); -NODES[1675].Fix(BODY_FORCE_Y); -NODES[1675].Fix(BODY_FORCE_Z); -NODES[1676].Fix(BODY_FORCE_X); -NODES[1676].Fix(BODY_FORCE_Y); -NODES[1676].Fix(BODY_FORCE_Z); -NODES[1677].Fix(BODY_FORCE_X); -NODES[1677].Fix(BODY_FORCE_Y); -NODES[1677].Fix(BODY_FORCE_Z); -NODES[1678].Fix(BODY_FORCE_X); -NODES[1678].Fix(BODY_FORCE_Y); -NODES[1678].Fix(BODY_FORCE_Z); -NODES[1679].Fix(BODY_FORCE_X); -NODES[1679].Fix(BODY_FORCE_Y); -NODES[1679].Fix(BODY_FORCE_Z); -NODES[1680].Fix(BODY_FORCE_X); -NODES[1680].Fix(BODY_FORCE_Y); -NODES[1680].Fix(BODY_FORCE_Z); -NODES[1681].Fix(BODY_FORCE_X); -NODES[1681].Fix(BODY_FORCE_Y); -NODES[1681].Fix(BODY_FORCE_Z); -NODES[1682].Fix(BODY_FORCE_X); -NODES[1682].Fix(BODY_FORCE_Y); -NODES[1682].Fix(BODY_FORCE_Z); -NODES[1683].Fix(BODY_FORCE_X); -NODES[1683].Fix(BODY_FORCE_Y); -NODES[1683].Fix(BODY_FORCE_Z); -NODES[1684].Fix(BODY_FORCE_X); -NODES[1684].Fix(BODY_FORCE_Y); -NODES[1684].Fix(BODY_FORCE_Z); -NODES[1685].Fix(BODY_FORCE_X); -NODES[1685].Fix(BODY_FORCE_Y); -NODES[1685].Fix(BODY_FORCE_Z); -NODES[1686].Fix(BODY_FORCE_X); -NODES[1686].Fix(BODY_FORCE_Y); -NODES[1686].Fix(BODY_FORCE_Z); -NODES[1687].Fix(BODY_FORCE_X); -NODES[1687].Fix(BODY_FORCE_Y); -NODES[1687].Fix(BODY_FORCE_Z); -NODES[1688].Fix(BODY_FORCE_X); -NODES[1688].Fix(BODY_FORCE_Y); -NODES[1688].Fix(BODY_FORCE_Z); -NODES[1689].Fix(BODY_FORCE_X); -NODES[1689].Fix(BODY_FORCE_Y); -NODES[1689].Fix(BODY_FORCE_Z); -NODES[1691].Fix(BODY_FORCE_X); -NODES[1691].Fix(BODY_FORCE_Y); -NODES[1691].Fix(BODY_FORCE_Z); -NODES[1692].Fix(BODY_FORCE_X); -NODES[1692].Fix(BODY_FORCE_Y); -NODES[1692].Fix(BODY_FORCE_Z); -NODES[1693].Fix(BODY_FORCE_X); -NODES[1693].Fix(BODY_FORCE_Y); -NODES[1693].Fix(BODY_FORCE_Z); -NODES[1694].Fix(BODY_FORCE_X); -NODES[1694].Fix(BODY_FORCE_Y); -NODES[1694].Fix(BODY_FORCE_Z); -NODES[1695].Fix(BODY_FORCE_X); -NODES[1695].Fix(BODY_FORCE_Y); -NODES[1695].Fix(BODY_FORCE_Z); -NODES[1696].Fix(BODY_FORCE_X); -NODES[1696].Fix(BODY_FORCE_Y); -NODES[1696].Fix(BODY_FORCE_Z); -NODES[1697].Fix(BODY_FORCE_X); -NODES[1697].Fix(BODY_FORCE_Y); -NODES[1697].Fix(BODY_FORCE_Z); -NODES[1698].Fix(BODY_FORCE_X); -NODES[1698].Fix(BODY_FORCE_Y); -NODES[1698].Fix(BODY_FORCE_Z); -NODES[1699].Fix(BODY_FORCE_X); -NODES[1699].Fix(BODY_FORCE_Y); -NODES[1699].Fix(BODY_FORCE_Z); -NODES[1700].Fix(BODY_FORCE_X); -NODES[1700].Fix(BODY_FORCE_Y); -NODES[1700].Fix(BODY_FORCE_Z); -NODES[1701].Fix(BODY_FORCE_X); -NODES[1701].Fix(BODY_FORCE_Y); -NODES[1701].Fix(BODY_FORCE_Z); -NODES[1702].Fix(BODY_FORCE_X); -NODES[1702].Fix(BODY_FORCE_Y); -NODES[1702].Fix(BODY_FORCE_Z); -NODES[1703].Fix(BODY_FORCE_X); -NODES[1703].Fix(BODY_FORCE_Y); -NODES[1703].Fix(BODY_FORCE_Z); -NODES[1704].Fix(BODY_FORCE_X); -NODES[1704].Fix(BODY_FORCE_Y); -NODES[1704].Fix(BODY_FORCE_Z); -NODES[1705].Fix(BODY_FORCE_X); -NODES[1705].Fix(BODY_FORCE_Y); -NODES[1705].Fix(BODY_FORCE_Z); -NODES[1706].Fix(BODY_FORCE_X); -NODES[1706].Fix(BODY_FORCE_Y); -NODES[1706].Fix(BODY_FORCE_Z); -NODES[1707].Fix(BODY_FORCE_X); -NODES[1707].Fix(BODY_FORCE_Y); -NODES[1707].Fix(BODY_FORCE_Z); -NODES[1708].Fix(BODY_FORCE_X); -NODES[1708].Fix(BODY_FORCE_Y); -NODES[1708].Fix(BODY_FORCE_Z); -NODES[1709].Fix(BODY_FORCE_X); -NODES[1709].Fix(BODY_FORCE_Y); -NODES[1709].Fix(BODY_FORCE_Z); -NODES[1710].Fix(BODY_FORCE_X); -NODES[1710].Fix(BODY_FORCE_Y); -NODES[1710].Fix(BODY_FORCE_Z); -NODES[1711].Fix(BODY_FORCE_X); -NODES[1711].Fix(BODY_FORCE_Y); -NODES[1711].Fix(BODY_FORCE_Z); -NODES[1712].Fix(BODY_FORCE_X); -NODES[1712].Fix(BODY_FORCE_Y); -NODES[1712].Fix(BODY_FORCE_Z); -NODES[1713].Fix(BODY_FORCE_X); -NODES[1713].Fix(BODY_FORCE_Y); -NODES[1713].Fix(BODY_FORCE_Z); -NODES[1714].Fix(BODY_FORCE_X); -NODES[1714].Fix(BODY_FORCE_Y); -NODES[1714].Fix(BODY_FORCE_Z); -NODES[1715].Fix(BODY_FORCE_X); -NODES[1715].Fix(BODY_FORCE_Y); -NODES[1715].Fix(BODY_FORCE_Z); -NODES[1716].Fix(BODY_FORCE_X); -NODES[1716].Fix(BODY_FORCE_Y); -NODES[1716].Fix(BODY_FORCE_Z); -NODES[1717].Fix(BODY_FORCE_X); -NODES[1717].Fix(BODY_FORCE_Y); -NODES[1717].Fix(BODY_FORCE_Z); -NODES[1718].Fix(BODY_FORCE_X); -NODES[1718].Fix(BODY_FORCE_Y); -NODES[1718].Fix(BODY_FORCE_Z); -NODES[1719].Fix(BODY_FORCE_X); -NODES[1719].Fix(BODY_FORCE_Y); -NODES[1719].Fix(BODY_FORCE_Z); -NODES[1720].Fix(BODY_FORCE_X); -NODES[1720].Fix(BODY_FORCE_Y); -NODES[1720].Fix(BODY_FORCE_Z); -NODES[1721].Fix(BODY_FORCE_X); -NODES[1721].Fix(BODY_FORCE_Y); -NODES[1721].Fix(BODY_FORCE_Z); -NODES[1722].Fix(BODY_FORCE_X); -NODES[1722].Fix(BODY_FORCE_Y); -NODES[1722].Fix(BODY_FORCE_Z); -NODES[1723].Fix(BODY_FORCE_X); -NODES[1723].Fix(BODY_FORCE_Y); -NODES[1723].Fix(BODY_FORCE_Z); -NODES[1724].Fix(BODY_FORCE_X); -NODES[1724].Fix(BODY_FORCE_Y); -NODES[1724].Fix(BODY_FORCE_Z); -NODES[1725].Fix(BODY_FORCE_X); -NODES[1725].Fix(BODY_FORCE_Y); -NODES[1725].Fix(BODY_FORCE_Z); -NODES[1726].Fix(BODY_FORCE_X); -NODES[1726].Fix(BODY_FORCE_Y); -NODES[1726].Fix(BODY_FORCE_Z); -NODES[1727].Fix(BODY_FORCE_X); -NODES[1727].Fix(BODY_FORCE_Y); -NODES[1727].Fix(BODY_FORCE_Z); -NODES[1728].Fix(BODY_FORCE_X); -NODES[1728].Fix(BODY_FORCE_Y); -NODES[1728].Fix(BODY_FORCE_Z); -NODES[1730].Fix(BODY_FORCE_X); -NODES[1730].Fix(BODY_FORCE_Y); -NODES[1730].Fix(BODY_FORCE_Z); -NODES[1731].Fix(BODY_FORCE_X); -NODES[1731].Fix(BODY_FORCE_Y); -NODES[1731].Fix(BODY_FORCE_Z); -NODES[1732].Fix(BODY_FORCE_X); -NODES[1732].Fix(BODY_FORCE_Y); -NODES[1732].Fix(BODY_FORCE_Z); -NODES[1733].Fix(BODY_FORCE_X); -NODES[1733].Fix(BODY_FORCE_Y); -NODES[1733].Fix(BODY_FORCE_Z); -NODES[1734].Fix(BODY_FORCE_X); -NODES[1734].Fix(BODY_FORCE_Y); -NODES[1734].Fix(BODY_FORCE_Z); -NODES[1735].Fix(BODY_FORCE_X); -NODES[1735].Fix(BODY_FORCE_Y); -NODES[1735].Fix(BODY_FORCE_Z); -NODES[1736].Fix(BODY_FORCE_X); -NODES[1736].Fix(BODY_FORCE_Y); -NODES[1736].Fix(BODY_FORCE_Z); -NODES[1737].Fix(BODY_FORCE_X); -NODES[1737].Fix(BODY_FORCE_Y); -NODES[1737].Fix(BODY_FORCE_Z); -NODES[1738].Fix(BODY_FORCE_X); -NODES[1738].Fix(BODY_FORCE_Y); -NODES[1738].Fix(BODY_FORCE_Z); -NODES[1739].Fix(BODY_FORCE_X); -NODES[1739].Fix(BODY_FORCE_Y); -NODES[1739].Fix(BODY_FORCE_Z); -NODES[1740].Fix(BODY_FORCE_X); -NODES[1740].Fix(BODY_FORCE_Y); -NODES[1740].Fix(BODY_FORCE_Z); -NODES[1741].Fix(BODY_FORCE_X); -NODES[1741].Fix(BODY_FORCE_Y); -NODES[1741].Fix(BODY_FORCE_Z); -NODES[1742].Fix(BODY_FORCE_X); -NODES[1742].Fix(BODY_FORCE_Y); -NODES[1742].Fix(BODY_FORCE_Z); -NODES[1743].Fix(BODY_FORCE_X); -NODES[1743].Fix(BODY_FORCE_Y); -NODES[1743].Fix(BODY_FORCE_Z); -NODES[1744].Fix(BODY_FORCE_X); -NODES[1744].Fix(BODY_FORCE_Y); -NODES[1744].Fix(BODY_FORCE_Z); -NODES[1745].Fix(BODY_FORCE_X); -NODES[1745].Fix(BODY_FORCE_Y); -NODES[1745].Fix(BODY_FORCE_Z); -NODES[1746].Fix(BODY_FORCE_X); -NODES[1746].Fix(BODY_FORCE_Y); -NODES[1746].Fix(BODY_FORCE_Z); -NODES[1747].Fix(BODY_FORCE_X); -NODES[1747].Fix(BODY_FORCE_Y); -NODES[1747].Fix(BODY_FORCE_Z); -NODES[1748].Fix(BODY_FORCE_X); -NODES[1748].Fix(BODY_FORCE_Y); -NODES[1748].Fix(BODY_FORCE_Z); -NODES[1749].Fix(BODY_FORCE_X); -NODES[1749].Fix(BODY_FORCE_Y); -NODES[1749].Fix(BODY_FORCE_Z); -NODES[1750].Fix(BODY_FORCE_X); -NODES[1750].Fix(BODY_FORCE_Y); -NODES[1750].Fix(BODY_FORCE_Z); -NODES[1751].Fix(BODY_FORCE_X); -NODES[1751].Fix(BODY_FORCE_Y); -NODES[1751].Fix(BODY_FORCE_Z); -NODES[1752].Fix(BODY_FORCE_X); -NODES[1752].Fix(BODY_FORCE_Y); -NODES[1752].Fix(BODY_FORCE_Z); -NODES[1753].Fix(BODY_FORCE_X); -NODES[1753].Fix(BODY_FORCE_Y); -NODES[1753].Fix(BODY_FORCE_Z); -NODES[1754].Fix(BODY_FORCE_X); -NODES[1754].Fix(BODY_FORCE_Y); -NODES[1754].Fix(BODY_FORCE_Z); -NODES[1755].Fix(BODY_FORCE_X); -NODES[1755].Fix(BODY_FORCE_Y); -NODES[1755].Fix(BODY_FORCE_Z); -NODES[1756].Fix(BODY_FORCE_X); -NODES[1756].Fix(BODY_FORCE_Y); -NODES[1756].Fix(BODY_FORCE_Z); -NODES[1757].Fix(BODY_FORCE_X); -NODES[1757].Fix(BODY_FORCE_Y); -NODES[1757].Fix(BODY_FORCE_Z); -NODES[1758].Fix(BODY_FORCE_X); -NODES[1758].Fix(BODY_FORCE_Y); -NODES[1758].Fix(BODY_FORCE_Z); -NODES[1759].Fix(BODY_FORCE_X); -NODES[1759].Fix(BODY_FORCE_Y); -NODES[1759].Fix(BODY_FORCE_Z); -NODES[1760].Fix(BODY_FORCE_X); -NODES[1760].Fix(BODY_FORCE_Y); -NODES[1760].Fix(BODY_FORCE_Z); -NODES[1761].Fix(BODY_FORCE_X); -NODES[1761].Fix(BODY_FORCE_Y); -NODES[1761].Fix(BODY_FORCE_Z); -NODES[1762].Fix(BODY_FORCE_X); -NODES[1762].Fix(BODY_FORCE_Y); -NODES[1762].Fix(BODY_FORCE_Z); -NODES[1763].Fix(BODY_FORCE_X); -NODES[1763].Fix(BODY_FORCE_Y); -NODES[1763].Fix(BODY_FORCE_Z); -NODES[1764].Fix(BODY_FORCE_X); -NODES[1764].Fix(BODY_FORCE_Y); -NODES[1764].Fix(BODY_FORCE_Z); -NODES[1765].Fix(BODY_FORCE_X); -NODES[1765].Fix(BODY_FORCE_Y); -NODES[1765].Fix(BODY_FORCE_Z); -NODES[1766].Fix(BODY_FORCE_X); -NODES[1766].Fix(BODY_FORCE_Y); -NODES[1766].Fix(BODY_FORCE_Z); -NODES[1768].Fix(BODY_FORCE_X); -NODES[1768].Fix(BODY_FORCE_Y); -NODES[1768].Fix(BODY_FORCE_Z); -NODES[1769].Fix(BODY_FORCE_X); -NODES[1769].Fix(BODY_FORCE_Y); -NODES[1769].Fix(BODY_FORCE_Z); -NODES[1770].Fix(BODY_FORCE_X); -NODES[1770].Fix(BODY_FORCE_Y); -NODES[1770].Fix(BODY_FORCE_Z); -NODES[1771].Fix(BODY_FORCE_X); -NODES[1771].Fix(BODY_FORCE_Y); -NODES[1771].Fix(BODY_FORCE_Z); -NODES[1772].Fix(BODY_FORCE_X); -NODES[1772].Fix(BODY_FORCE_Y); -NODES[1772].Fix(BODY_FORCE_Z); -NODES[1773].Fix(BODY_FORCE_X); -NODES[1773].Fix(BODY_FORCE_Y); -NODES[1773].Fix(BODY_FORCE_Z); -NODES[1774].Fix(BODY_FORCE_X); -NODES[1774].Fix(BODY_FORCE_Y); -NODES[1774].Fix(BODY_FORCE_Z); -NODES[1775].Fix(BODY_FORCE_X); -NODES[1775].Fix(BODY_FORCE_Y); -NODES[1775].Fix(BODY_FORCE_Z); -NODES[1776].Fix(BODY_FORCE_X); -NODES[1776].Fix(BODY_FORCE_Y); -NODES[1776].Fix(BODY_FORCE_Z); -NODES[1777].Fix(BODY_FORCE_X); -NODES[1777].Fix(BODY_FORCE_Y); -NODES[1777].Fix(BODY_FORCE_Z); -NODES[1778].Fix(BODY_FORCE_X); -NODES[1778].Fix(BODY_FORCE_Y); -NODES[1778].Fix(BODY_FORCE_Z); -NODES[1779].Fix(BODY_FORCE_X); -NODES[1779].Fix(BODY_FORCE_Y); -NODES[1779].Fix(BODY_FORCE_Z); -NODES[1780].Fix(BODY_FORCE_X); -NODES[1780].Fix(BODY_FORCE_Y); -NODES[1780].Fix(BODY_FORCE_Z); -NODES[1781].Fix(BODY_FORCE_X); -NODES[1781].Fix(BODY_FORCE_Y); -NODES[1781].Fix(BODY_FORCE_Z); -NODES[1782].Fix(BODY_FORCE_X); -NODES[1782].Fix(BODY_FORCE_Y); -NODES[1782].Fix(BODY_FORCE_Z); -NODES[1783].Fix(BODY_FORCE_X); -NODES[1783].Fix(BODY_FORCE_Y); -NODES[1783].Fix(BODY_FORCE_Z); -NODES[1784].Fix(BODY_FORCE_X); -NODES[1784].Fix(BODY_FORCE_Y); -NODES[1784].Fix(BODY_FORCE_Z); -NODES[1785].Fix(BODY_FORCE_X); -NODES[1785].Fix(BODY_FORCE_Y); -NODES[1785].Fix(BODY_FORCE_Z); -NODES[1786].Fix(BODY_FORCE_X); -NODES[1786].Fix(BODY_FORCE_Y); -NODES[1786].Fix(BODY_FORCE_Z); -NODES[1787].Fix(BODY_FORCE_X); -NODES[1787].Fix(BODY_FORCE_Y); -NODES[1787].Fix(BODY_FORCE_Z); -NODES[1788].Fix(BODY_FORCE_X); -NODES[1788].Fix(BODY_FORCE_Y); -NODES[1788].Fix(BODY_FORCE_Z); -NODES[1789].Fix(BODY_FORCE_X); -NODES[1789].Fix(BODY_FORCE_Y); -NODES[1789].Fix(BODY_FORCE_Z); -NODES[1790].Fix(BODY_FORCE_X); -NODES[1790].Fix(BODY_FORCE_Y); -NODES[1790].Fix(BODY_FORCE_Z); -NODES[1791].Fix(BODY_FORCE_X); -NODES[1791].Fix(BODY_FORCE_Y); -NODES[1791].Fix(BODY_FORCE_Z); -NODES[1792].Fix(BODY_FORCE_X); -NODES[1792].Fix(BODY_FORCE_Y); -NODES[1792].Fix(BODY_FORCE_Z); -NODES[1793].Fix(BODY_FORCE_X); -NODES[1793].Fix(BODY_FORCE_Y); -NODES[1793].Fix(BODY_FORCE_Z); -NODES[1794].Fix(BODY_FORCE_X); -NODES[1794].Fix(BODY_FORCE_Y); -NODES[1794].Fix(BODY_FORCE_Z); -NODES[1795].Fix(BODY_FORCE_X); -NODES[1795].Fix(BODY_FORCE_Y); -NODES[1795].Fix(BODY_FORCE_Z); -NODES[1796].Fix(BODY_FORCE_X); -NODES[1796].Fix(BODY_FORCE_Y); -NODES[1796].Fix(BODY_FORCE_Z); -NODES[1797].Fix(BODY_FORCE_X); -NODES[1797].Fix(BODY_FORCE_Y); -NODES[1797].Fix(BODY_FORCE_Z); -NODES[1798].Fix(BODY_FORCE_X); -NODES[1798].Fix(BODY_FORCE_Y); -NODES[1798].Fix(BODY_FORCE_Z); -NODES[1799].Fix(BODY_FORCE_X); -NODES[1799].Fix(BODY_FORCE_Y); -NODES[1799].Fix(BODY_FORCE_Z); -NODES[1800].Fix(BODY_FORCE_X); -NODES[1800].Fix(BODY_FORCE_Y); -NODES[1800].Fix(BODY_FORCE_Z); -NODES[1801].Fix(BODY_FORCE_X); -NODES[1801].Fix(BODY_FORCE_Y); -NODES[1801].Fix(BODY_FORCE_Z); -NODES[1802].Fix(BODY_FORCE_X); -NODES[1802].Fix(BODY_FORCE_Y); -NODES[1802].Fix(BODY_FORCE_Z); -NODES[1803].Fix(BODY_FORCE_X); -NODES[1803].Fix(BODY_FORCE_Y); -NODES[1803].Fix(BODY_FORCE_Z); -NODES[1805].Fix(BODY_FORCE_X); -NODES[1805].Fix(BODY_FORCE_Y); -NODES[1805].Fix(BODY_FORCE_Z); -NODES[1806].Fix(BODY_FORCE_X); -NODES[1806].Fix(BODY_FORCE_Y); -NODES[1806].Fix(BODY_FORCE_Z); -NODES[1807].Fix(BODY_FORCE_X); -NODES[1807].Fix(BODY_FORCE_Y); -NODES[1807].Fix(BODY_FORCE_Z); -NODES[1808].Fix(BODY_FORCE_X); -NODES[1808].Fix(BODY_FORCE_Y); -NODES[1808].Fix(BODY_FORCE_Z); -NODES[1809].Fix(BODY_FORCE_X); -NODES[1809].Fix(BODY_FORCE_Y); -NODES[1809].Fix(BODY_FORCE_Z); -NODES[1810].Fix(BODY_FORCE_X); -NODES[1810].Fix(BODY_FORCE_Y); -NODES[1810].Fix(BODY_FORCE_Z); -NODES[1811].Fix(BODY_FORCE_X); -NODES[1811].Fix(BODY_FORCE_Y); -NODES[1811].Fix(BODY_FORCE_Z); -NODES[1812].Fix(BODY_FORCE_X); -NODES[1812].Fix(BODY_FORCE_Y); -NODES[1812].Fix(BODY_FORCE_Z); -NODES[1813].Fix(BODY_FORCE_X); -NODES[1813].Fix(BODY_FORCE_Y); -NODES[1813].Fix(BODY_FORCE_Z); -NODES[1814].Fix(BODY_FORCE_X); -NODES[1814].Fix(BODY_FORCE_Y); -NODES[1814].Fix(BODY_FORCE_Z); -NODES[1815].Fix(BODY_FORCE_X); -NODES[1815].Fix(BODY_FORCE_Y); -NODES[1815].Fix(BODY_FORCE_Z); -NODES[1816].Fix(BODY_FORCE_X); -NODES[1816].Fix(BODY_FORCE_Y); -NODES[1816].Fix(BODY_FORCE_Z); -NODES[1817].Fix(BODY_FORCE_X); -NODES[1817].Fix(BODY_FORCE_Y); -NODES[1817].Fix(BODY_FORCE_Z); -NODES[1818].Fix(BODY_FORCE_X); -NODES[1818].Fix(BODY_FORCE_Y); -NODES[1818].Fix(BODY_FORCE_Z); -NODES[1819].Fix(BODY_FORCE_X); -NODES[1819].Fix(BODY_FORCE_Y); -NODES[1819].Fix(BODY_FORCE_Z); -NODES[1820].Fix(BODY_FORCE_X); -NODES[1820].Fix(BODY_FORCE_Y); -NODES[1820].Fix(BODY_FORCE_Z); -NODES[1821].Fix(BODY_FORCE_X); -NODES[1821].Fix(BODY_FORCE_Y); -NODES[1821].Fix(BODY_FORCE_Z); -NODES[1822].Fix(BODY_FORCE_X); -NODES[1822].Fix(BODY_FORCE_Y); -NODES[1822].Fix(BODY_FORCE_Z); -NODES[1823].Fix(BODY_FORCE_X); -NODES[1823].Fix(BODY_FORCE_Y); -NODES[1823].Fix(BODY_FORCE_Z); -NODES[1824].Fix(BODY_FORCE_X); -NODES[1824].Fix(BODY_FORCE_Y); -NODES[1824].Fix(BODY_FORCE_Z); -NODES[1825].Fix(BODY_FORCE_X); -NODES[1825].Fix(BODY_FORCE_Y); -NODES[1825].Fix(BODY_FORCE_Z); -NODES[1826].Fix(BODY_FORCE_X); -NODES[1826].Fix(BODY_FORCE_Y); -NODES[1826].Fix(BODY_FORCE_Z); -NODES[1827].Fix(BODY_FORCE_X); -NODES[1827].Fix(BODY_FORCE_Y); -NODES[1827].Fix(BODY_FORCE_Z); -NODES[1828].Fix(BODY_FORCE_X); -NODES[1828].Fix(BODY_FORCE_Y); -NODES[1828].Fix(BODY_FORCE_Z); -NODES[1829].Fix(BODY_FORCE_X); -NODES[1829].Fix(BODY_FORCE_Y); -NODES[1829].Fix(BODY_FORCE_Z); -NODES[1830].Fix(BODY_FORCE_X); -NODES[1830].Fix(BODY_FORCE_Y); -NODES[1830].Fix(BODY_FORCE_Z); -NODES[1831].Fix(BODY_FORCE_X); -NODES[1831].Fix(BODY_FORCE_Y); -NODES[1831].Fix(BODY_FORCE_Z); -NODES[1832].Fix(BODY_FORCE_X); -NODES[1832].Fix(BODY_FORCE_Y); -NODES[1832].Fix(BODY_FORCE_Z); -NODES[1833].Fix(BODY_FORCE_X); -NODES[1833].Fix(BODY_FORCE_Y); -NODES[1833].Fix(BODY_FORCE_Z); -NODES[1834].Fix(BODY_FORCE_X); -NODES[1834].Fix(BODY_FORCE_Y); -NODES[1834].Fix(BODY_FORCE_Z); -NODES[1835].Fix(BODY_FORCE_X); -NODES[1835].Fix(BODY_FORCE_Y); -NODES[1835].Fix(BODY_FORCE_Z); -NODES[1836].Fix(BODY_FORCE_X); -NODES[1836].Fix(BODY_FORCE_Y); -NODES[1836].Fix(BODY_FORCE_Z); -NODES[1837].Fix(BODY_FORCE_X); -NODES[1837].Fix(BODY_FORCE_Y); -NODES[1837].Fix(BODY_FORCE_Z); -NODES[1838].Fix(BODY_FORCE_X); -NODES[1838].Fix(BODY_FORCE_Y); -NODES[1838].Fix(BODY_FORCE_Z); -NODES[1840].Fix(BODY_FORCE_X); -NODES[1840].Fix(BODY_FORCE_Y); -NODES[1840].Fix(BODY_FORCE_Z); -NODES[1841].Fix(BODY_FORCE_X); -NODES[1841].Fix(BODY_FORCE_Y); -NODES[1841].Fix(BODY_FORCE_Z); -NODES[1842].Fix(BODY_FORCE_X); -NODES[1842].Fix(BODY_FORCE_Y); -NODES[1842].Fix(BODY_FORCE_Z); -NODES[1843].Fix(BODY_FORCE_X); -NODES[1843].Fix(BODY_FORCE_Y); -NODES[1843].Fix(BODY_FORCE_Z); -NODES[1844].Fix(BODY_FORCE_X); -NODES[1844].Fix(BODY_FORCE_Y); -NODES[1844].Fix(BODY_FORCE_Z); -NODES[1845].Fix(BODY_FORCE_X); -NODES[1845].Fix(BODY_FORCE_Y); -NODES[1845].Fix(BODY_FORCE_Z); -NODES[1846].Fix(BODY_FORCE_X); -NODES[1846].Fix(BODY_FORCE_Y); -NODES[1846].Fix(BODY_FORCE_Z); -NODES[1847].Fix(BODY_FORCE_X); -NODES[1847].Fix(BODY_FORCE_Y); -NODES[1847].Fix(BODY_FORCE_Z); -NODES[1848].Fix(BODY_FORCE_X); -NODES[1848].Fix(BODY_FORCE_Y); -NODES[1848].Fix(BODY_FORCE_Z); -NODES[1849].Fix(BODY_FORCE_X); -NODES[1849].Fix(BODY_FORCE_Y); -NODES[1849].Fix(BODY_FORCE_Z); -NODES[1850].Fix(BODY_FORCE_X); -NODES[1850].Fix(BODY_FORCE_Y); -NODES[1850].Fix(BODY_FORCE_Z); -NODES[1851].Fix(BODY_FORCE_X); -NODES[1851].Fix(BODY_FORCE_Y); -NODES[1851].Fix(BODY_FORCE_Z); -NODES[1852].Fix(BODY_FORCE_X); -NODES[1852].Fix(BODY_FORCE_Y); -NODES[1852].Fix(BODY_FORCE_Z); -NODES[1853].Fix(BODY_FORCE_X); -NODES[1853].Fix(BODY_FORCE_Y); -NODES[1853].Fix(BODY_FORCE_Z); -NODES[1854].Fix(BODY_FORCE_X); -NODES[1854].Fix(BODY_FORCE_Y); -NODES[1854].Fix(BODY_FORCE_Z); -NODES[1855].Fix(BODY_FORCE_X); -NODES[1855].Fix(BODY_FORCE_Y); -NODES[1855].Fix(BODY_FORCE_Z); -NODES[1856].Fix(BODY_FORCE_X); -NODES[1856].Fix(BODY_FORCE_Y); -NODES[1856].Fix(BODY_FORCE_Z); -NODES[1857].Fix(BODY_FORCE_X); -NODES[1857].Fix(BODY_FORCE_Y); -NODES[1857].Fix(BODY_FORCE_Z); -NODES[1858].Fix(BODY_FORCE_X); -NODES[1858].Fix(BODY_FORCE_Y); -NODES[1858].Fix(BODY_FORCE_Z); -NODES[1859].Fix(BODY_FORCE_X); -NODES[1859].Fix(BODY_FORCE_Y); -NODES[1859].Fix(BODY_FORCE_Z); -NODES[1860].Fix(BODY_FORCE_X); -NODES[1860].Fix(BODY_FORCE_Y); -NODES[1860].Fix(BODY_FORCE_Z); -NODES[1861].Fix(BODY_FORCE_X); -NODES[1861].Fix(BODY_FORCE_Y); -NODES[1861].Fix(BODY_FORCE_Z); -NODES[1862].Fix(BODY_FORCE_X); -NODES[1862].Fix(BODY_FORCE_Y); -NODES[1862].Fix(BODY_FORCE_Z); -NODES[1863].Fix(BODY_FORCE_X); -NODES[1863].Fix(BODY_FORCE_Y); -NODES[1863].Fix(BODY_FORCE_Z); -NODES[1864].Fix(BODY_FORCE_X); -NODES[1864].Fix(BODY_FORCE_Y); -NODES[1864].Fix(BODY_FORCE_Z); -NODES[1865].Fix(BODY_FORCE_X); -NODES[1865].Fix(BODY_FORCE_Y); -NODES[1865].Fix(BODY_FORCE_Z); -NODES[1866].Fix(BODY_FORCE_X); -NODES[1866].Fix(BODY_FORCE_Y); -NODES[1866].Fix(BODY_FORCE_Z); -NODES[1867].Fix(BODY_FORCE_X); -NODES[1867].Fix(BODY_FORCE_Y); -NODES[1867].Fix(BODY_FORCE_Z); -NODES[1868].Fix(BODY_FORCE_X); -NODES[1868].Fix(BODY_FORCE_Y); -NODES[1868].Fix(BODY_FORCE_Z); -NODES[1869].Fix(BODY_FORCE_X); -NODES[1869].Fix(BODY_FORCE_Y); -NODES[1869].Fix(BODY_FORCE_Z); -NODES[1870].Fix(BODY_FORCE_X); -NODES[1870].Fix(BODY_FORCE_Y); -NODES[1870].Fix(BODY_FORCE_Z); -NODES[1871].Fix(BODY_FORCE_X); -NODES[1871].Fix(BODY_FORCE_Y); -NODES[1871].Fix(BODY_FORCE_Z); -NODES[1872].Fix(BODY_FORCE_X); -NODES[1872].Fix(BODY_FORCE_Y); -NODES[1872].Fix(BODY_FORCE_Z); -NODES[1874].Fix(BODY_FORCE_X); -NODES[1874].Fix(BODY_FORCE_Y); -NODES[1874].Fix(BODY_FORCE_Z); -NODES[1875].Fix(BODY_FORCE_X); -NODES[1875].Fix(BODY_FORCE_Y); -NODES[1875].Fix(BODY_FORCE_Z); -NODES[1876].Fix(BODY_FORCE_X); -NODES[1876].Fix(BODY_FORCE_Y); -NODES[1876].Fix(BODY_FORCE_Z); -NODES[1877].Fix(BODY_FORCE_X); -NODES[1877].Fix(BODY_FORCE_Y); -NODES[1877].Fix(BODY_FORCE_Z); -NODES[1878].Fix(BODY_FORCE_X); -NODES[1878].Fix(BODY_FORCE_Y); -NODES[1878].Fix(BODY_FORCE_Z); -NODES[1879].Fix(BODY_FORCE_X); -NODES[1879].Fix(BODY_FORCE_Y); -NODES[1879].Fix(BODY_FORCE_Z); -NODES[1880].Fix(BODY_FORCE_X); -NODES[1880].Fix(BODY_FORCE_Y); -NODES[1880].Fix(BODY_FORCE_Z); -NODES[1881].Fix(BODY_FORCE_X); -NODES[1881].Fix(BODY_FORCE_Y); -NODES[1881].Fix(BODY_FORCE_Z); -NODES[1882].Fix(BODY_FORCE_X); -NODES[1882].Fix(BODY_FORCE_Y); -NODES[1882].Fix(BODY_FORCE_Z); -NODES[1883].Fix(BODY_FORCE_X); -NODES[1883].Fix(BODY_FORCE_Y); -NODES[1883].Fix(BODY_FORCE_Z); -NODES[1884].Fix(BODY_FORCE_X); -NODES[1884].Fix(BODY_FORCE_Y); -NODES[1884].Fix(BODY_FORCE_Z); -NODES[1885].Fix(BODY_FORCE_X); -NODES[1885].Fix(BODY_FORCE_Y); -NODES[1885].Fix(BODY_FORCE_Z); -NODES[1886].Fix(BODY_FORCE_X); -NODES[1886].Fix(BODY_FORCE_Y); -NODES[1886].Fix(BODY_FORCE_Z); -NODES[1887].Fix(BODY_FORCE_X); -NODES[1887].Fix(BODY_FORCE_Y); -NODES[1887].Fix(BODY_FORCE_Z); -NODES[1888].Fix(BODY_FORCE_X); -NODES[1888].Fix(BODY_FORCE_Y); -NODES[1888].Fix(BODY_FORCE_Z); -NODES[1889].Fix(BODY_FORCE_X); -NODES[1889].Fix(BODY_FORCE_Y); -NODES[1889].Fix(BODY_FORCE_Z); -NODES[1890].Fix(BODY_FORCE_X); -NODES[1890].Fix(BODY_FORCE_Y); -NODES[1890].Fix(BODY_FORCE_Z); -NODES[1891].Fix(BODY_FORCE_X); -NODES[1891].Fix(BODY_FORCE_Y); -NODES[1891].Fix(BODY_FORCE_Z); -NODES[1892].Fix(BODY_FORCE_X); -NODES[1892].Fix(BODY_FORCE_Y); -NODES[1892].Fix(BODY_FORCE_Z); -NODES[1893].Fix(BODY_FORCE_X); -NODES[1893].Fix(BODY_FORCE_Y); -NODES[1893].Fix(BODY_FORCE_Z); -NODES[1894].Fix(BODY_FORCE_X); -NODES[1894].Fix(BODY_FORCE_Y); -NODES[1894].Fix(BODY_FORCE_Z); -NODES[1895].Fix(BODY_FORCE_X); -NODES[1895].Fix(BODY_FORCE_Y); -NODES[1895].Fix(BODY_FORCE_Z); -NODES[1896].Fix(BODY_FORCE_X); -NODES[1896].Fix(BODY_FORCE_Y); -NODES[1896].Fix(BODY_FORCE_Z); -NODES[1897].Fix(BODY_FORCE_X); -NODES[1897].Fix(BODY_FORCE_Y); -NODES[1897].Fix(BODY_FORCE_Z); -NODES[1898].Fix(BODY_FORCE_X); -NODES[1898].Fix(BODY_FORCE_Y); -NODES[1898].Fix(BODY_FORCE_Z); -NODES[1899].Fix(BODY_FORCE_X); -NODES[1899].Fix(BODY_FORCE_Y); -NODES[1899].Fix(BODY_FORCE_Z); -NODES[1900].Fix(BODY_FORCE_X); -NODES[1900].Fix(BODY_FORCE_Y); -NODES[1900].Fix(BODY_FORCE_Z); -NODES[1901].Fix(BODY_FORCE_X); -NODES[1901].Fix(BODY_FORCE_Y); -NODES[1901].Fix(BODY_FORCE_Z); -NODES[1902].Fix(BODY_FORCE_X); -NODES[1902].Fix(BODY_FORCE_Y); -NODES[1902].Fix(BODY_FORCE_Z); -NODES[1903].Fix(BODY_FORCE_X); -NODES[1903].Fix(BODY_FORCE_Y); -NODES[1903].Fix(BODY_FORCE_Z); -NODES[1904].Fix(BODY_FORCE_X); -NODES[1904].Fix(BODY_FORCE_Y); -NODES[1904].Fix(BODY_FORCE_Z); -NODES[1905].Fix(BODY_FORCE_X); -NODES[1905].Fix(BODY_FORCE_Y); -NODES[1905].Fix(BODY_FORCE_Z); -NODES[1906].Fix(BODY_FORCE_X); -NODES[1906].Fix(BODY_FORCE_Y); -NODES[1906].Fix(BODY_FORCE_Z); -NODES[1907].Fix(BODY_FORCE_X); -NODES[1907].Fix(BODY_FORCE_Y); -NODES[1907].Fix(BODY_FORCE_Z); -NODES[1908].Fix(BODY_FORCE_X); -NODES[1908].Fix(BODY_FORCE_Y); -NODES[1908].Fix(BODY_FORCE_Z); -NODES[1910].Fix(BODY_FORCE_X); -NODES[1910].Fix(BODY_FORCE_Y); -NODES[1910].Fix(BODY_FORCE_Z); -NODES[1911].Fix(BODY_FORCE_X); -NODES[1911].Fix(BODY_FORCE_Y); -NODES[1911].Fix(BODY_FORCE_Z); -NODES[1912].Fix(BODY_FORCE_X); -NODES[1912].Fix(BODY_FORCE_Y); -NODES[1912].Fix(BODY_FORCE_Z); -NODES[1913].Fix(BODY_FORCE_X); -NODES[1913].Fix(BODY_FORCE_Y); -NODES[1913].Fix(BODY_FORCE_Z); -NODES[1914].Fix(BODY_FORCE_X); -NODES[1914].Fix(BODY_FORCE_Y); -NODES[1914].Fix(BODY_FORCE_Z); -NODES[1915].Fix(BODY_FORCE_X); -NODES[1915].Fix(BODY_FORCE_Y); -NODES[1915].Fix(BODY_FORCE_Z); -NODES[1916].Fix(BODY_FORCE_X); -NODES[1916].Fix(BODY_FORCE_Y); -NODES[1916].Fix(BODY_FORCE_Z); -NODES[1917].Fix(BODY_FORCE_X); -NODES[1917].Fix(BODY_FORCE_Y); -NODES[1917].Fix(BODY_FORCE_Z); -NODES[1918].Fix(BODY_FORCE_X); -NODES[1918].Fix(BODY_FORCE_Y); -NODES[1918].Fix(BODY_FORCE_Z); -NODES[1919].Fix(BODY_FORCE_X); -NODES[1919].Fix(BODY_FORCE_Y); -NODES[1919].Fix(BODY_FORCE_Z); -NODES[1920].Fix(BODY_FORCE_X); -NODES[1920].Fix(BODY_FORCE_Y); -NODES[1920].Fix(BODY_FORCE_Z); -NODES[1921].Fix(BODY_FORCE_X); -NODES[1921].Fix(BODY_FORCE_Y); -NODES[1921].Fix(BODY_FORCE_Z); -NODES[1922].Fix(BODY_FORCE_X); -NODES[1922].Fix(BODY_FORCE_Y); -NODES[1922].Fix(BODY_FORCE_Z); -NODES[1923].Fix(BODY_FORCE_X); -NODES[1923].Fix(BODY_FORCE_Y); -NODES[1923].Fix(BODY_FORCE_Z); -NODES[1924].Fix(BODY_FORCE_X); -NODES[1924].Fix(BODY_FORCE_Y); -NODES[1924].Fix(BODY_FORCE_Z); -NODES[1925].Fix(BODY_FORCE_X); -NODES[1925].Fix(BODY_FORCE_Y); -NODES[1925].Fix(BODY_FORCE_Z); -NODES[1926].Fix(BODY_FORCE_X); -NODES[1926].Fix(BODY_FORCE_Y); -NODES[1926].Fix(BODY_FORCE_Z); -NODES[1927].Fix(BODY_FORCE_X); -NODES[1927].Fix(BODY_FORCE_Y); -NODES[1927].Fix(BODY_FORCE_Z); -NODES[1928].Fix(BODY_FORCE_X); -NODES[1928].Fix(BODY_FORCE_Y); -NODES[1928].Fix(BODY_FORCE_Z); -NODES[1929].Fix(BODY_FORCE_X); -NODES[1929].Fix(BODY_FORCE_Y); -NODES[1929].Fix(BODY_FORCE_Z); -NODES[1930].Fix(BODY_FORCE_X); -NODES[1930].Fix(BODY_FORCE_Y); -NODES[1930].Fix(BODY_FORCE_Z); -NODES[1931].Fix(BODY_FORCE_X); -NODES[1931].Fix(BODY_FORCE_Y); -NODES[1931].Fix(BODY_FORCE_Z); -NODES[1932].Fix(BODY_FORCE_X); -NODES[1932].Fix(BODY_FORCE_Y); -NODES[1932].Fix(BODY_FORCE_Z); -NODES[1933].Fix(BODY_FORCE_X); -NODES[1933].Fix(BODY_FORCE_Y); -NODES[1933].Fix(BODY_FORCE_Z); -NODES[1934].Fix(BODY_FORCE_X); -NODES[1934].Fix(BODY_FORCE_Y); -NODES[1934].Fix(BODY_FORCE_Z); -NODES[1935].Fix(BODY_FORCE_X); -NODES[1935].Fix(BODY_FORCE_Y); -NODES[1935].Fix(BODY_FORCE_Z); -NODES[1936].Fix(BODY_FORCE_X); -NODES[1936].Fix(BODY_FORCE_Y); -NODES[1936].Fix(BODY_FORCE_Z); -NODES[1937].Fix(BODY_FORCE_X); -NODES[1937].Fix(BODY_FORCE_Y); -NODES[1937].Fix(BODY_FORCE_Z); -NODES[1938].Fix(BODY_FORCE_X); -NODES[1938].Fix(BODY_FORCE_Y); -NODES[1938].Fix(BODY_FORCE_Z); -NODES[1939].Fix(BODY_FORCE_X); -NODES[1939].Fix(BODY_FORCE_Y); -NODES[1939].Fix(BODY_FORCE_Z); -NODES[1940].Fix(BODY_FORCE_X); -NODES[1940].Fix(BODY_FORCE_Y); -NODES[1940].Fix(BODY_FORCE_Z); -NODES[1941].Fix(BODY_FORCE_X); -NODES[1941].Fix(BODY_FORCE_Y); -NODES[1941].Fix(BODY_FORCE_Z); -NODES[1942].Fix(BODY_FORCE_X); -NODES[1942].Fix(BODY_FORCE_Y); -NODES[1942].Fix(BODY_FORCE_Z); -NODES[1944].Fix(BODY_FORCE_X); -NODES[1944].Fix(BODY_FORCE_Y); -NODES[1944].Fix(BODY_FORCE_Z); -NODES[1945].Fix(BODY_FORCE_X); -NODES[1945].Fix(BODY_FORCE_Y); -NODES[1945].Fix(BODY_FORCE_Z); -NODES[1946].Fix(BODY_FORCE_X); -NODES[1946].Fix(BODY_FORCE_Y); -NODES[1946].Fix(BODY_FORCE_Z); -NODES[1947].Fix(BODY_FORCE_X); -NODES[1947].Fix(BODY_FORCE_Y); -NODES[1947].Fix(BODY_FORCE_Z); -NODES[1948].Fix(BODY_FORCE_X); -NODES[1948].Fix(BODY_FORCE_Y); -NODES[1948].Fix(BODY_FORCE_Z); -NODES[1949].Fix(BODY_FORCE_X); -NODES[1949].Fix(BODY_FORCE_Y); -NODES[1949].Fix(BODY_FORCE_Z); -NODES[1950].Fix(BODY_FORCE_X); -NODES[1950].Fix(BODY_FORCE_Y); -NODES[1950].Fix(BODY_FORCE_Z); -NODES[1951].Fix(BODY_FORCE_X); -NODES[1951].Fix(BODY_FORCE_Y); -NODES[1951].Fix(BODY_FORCE_Z); -NODES[1952].Fix(BODY_FORCE_X); -NODES[1952].Fix(BODY_FORCE_Y); -NODES[1952].Fix(BODY_FORCE_Z); -NODES[1953].Fix(BODY_FORCE_X); -NODES[1953].Fix(BODY_FORCE_Y); -NODES[1953].Fix(BODY_FORCE_Z); -NODES[1954].Fix(BODY_FORCE_X); -NODES[1954].Fix(BODY_FORCE_Y); -NODES[1954].Fix(BODY_FORCE_Z); -NODES[1955].Fix(BODY_FORCE_X); -NODES[1955].Fix(BODY_FORCE_Y); -NODES[1955].Fix(BODY_FORCE_Z); -NODES[1956].Fix(BODY_FORCE_X); -NODES[1956].Fix(BODY_FORCE_Y); -NODES[1956].Fix(BODY_FORCE_Z); -NODES[1957].Fix(BODY_FORCE_X); -NODES[1957].Fix(BODY_FORCE_Y); -NODES[1957].Fix(BODY_FORCE_Z); -NODES[1958].Fix(BODY_FORCE_X); -NODES[1958].Fix(BODY_FORCE_Y); -NODES[1958].Fix(BODY_FORCE_Z); -NODES[1959].Fix(BODY_FORCE_X); -NODES[1959].Fix(BODY_FORCE_Y); -NODES[1959].Fix(BODY_FORCE_Z); -NODES[1960].Fix(BODY_FORCE_X); -NODES[1960].Fix(BODY_FORCE_Y); -NODES[1960].Fix(BODY_FORCE_Z); -NODES[1961].Fix(BODY_FORCE_X); -NODES[1961].Fix(BODY_FORCE_Y); -NODES[1961].Fix(BODY_FORCE_Z); -NODES[1962].Fix(BODY_FORCE_X); -NODES[1962].Fix(BODY_FORCE_Y); -NODES[1962].Fix(BODY_FORCE_Z); -NODES[1963].Fix(BODY_FORCE_X); -NODES[1963].Fix(BODY_FORCE_Y); -NODES[1963].Fix(BODY_FORCE_Z); -NODES[1964].Fix(BODY_FORCE_X); -NODES[1964].Fix(BODY_FORCE_Y); -NODES[1964].Fix(BODY_FORCE_Z); -NODES[1965].Fix(BODY_FORCE_X); -NODES[1965].Fix(BODY_FORCE_Y); -NODES[1965].Fix(BODY_FORCE_Z); -NODES[1966].Fix(BODY_FORCE_X); -NODES[1966].Fix(BODY_FORCE_Y); -NODES[1966].Fix(BODY_FORCE_Z); -NODES[1967].Fix(BODY_FORCE_X); -NODES[1967].Fix(BODY_FORCE_Y); -NODES[1967].Fix(BODY_FORCE_Z); -NODES[1968].Fix(BODY_FORCE_X); -NODES[1968].Fix(BODY_FORCE_Y); -NODES[1968].Fix(BODY_FORCE_Z); -NODES[1969].Fix(BODY_FORCE_X); -NODES[1969].Fix(BODY_FORCE_Y); -NODES[1969].Fix(BODY_FORCE_Z); -NODES[1970].Fix(BODY_FORCE_X); -NODES[1970].Fix(BODY_FORCE_Y); -NODES[1970].Fix(BODY_FORCE_Z); -NODES[1971].Fix(BODY_FORCE_X); -NODES[1971].Fix(BODY_FORCE_Y); -NODES[1971].Fix(BODY_FORCE_Z); -NODES[1972].Fix(BODY_FORCE_X); -NODES[1972].Fix(BODY_FORCE_Y); -NODES[1972].Fix(BODY_FORCE_Z); -NODES[1973].Fix(BODY_FORCE_X); -NODES[1973].Fix(BODY_FORCE_Y); -NODES[1973].Fix(BODY_FORCE_Z); -NODES[1974].Fix(BODY_FORCE_X); -NODES[1974].Fix(BODY_FORCE_Y); -NODES[1974].Fix(BODY_FORCE_Z); -NODES[1976].Fix(BODY_FORCE_X); -NODES[1976].Fix(BODY_FORCE_Y); -NODES[1976].Fix(BODY_FORCE_Z); -NODES[1977].Fix(BODY_FORCE_X); -NODES[1977].Fix(BODY_FORCE_Y); -NODES[1977].Fix(BODY_FORCE_Z); -NODES[1978].Fix(BODY_FORCE_X); -NODES[1978].Fix(BODY_FORCE_Y); -NODES[1978].Fix(BODY_FORCE_Z); -NODES[1979].Fix(BODY_FORCE_X); -NODES[1979].Fix(BODY_FORCE_Y); -NODES[1979].Fix(BODY_FORCE_Z); -NODES[1980].Fix(BODY_FORCE_X); -NODES[1980].Fix(BODY_FORCE_Y); -NODES[1980].Fix(BODY_FORCE_Z); -NODES[1981].Fix(BODY_FORCE_X); -NODES[1981].Fix(BODY_FORCE_Y); -NODES[1981].Fix(BODY_FORCE_Z); -NODES[1982].Fix(BODY_FORCE_X); -NODES[1982].Fix(BODY_FORCE_Y); -NODES[1982].Fix(BODY_FORCE_Z); -NODES[1983].Fix(BODY_FORCE_X); -NODES[1983].Fix(BODY_FORCE_Y); -NODES[1983].Fix(BODY_FORCE_Z); -NODES[1984].Fix(BODY_FORCE_X); -NODES[1984].Fix(BODY_FORCE_Y); -NODES[1984].Fix(BODY_FORCE_Z); -NODES[1985].Fix(BODY_FORCE_X); -NODES[1985].Fix(BODY_FORCE_Y); -NODES[1985].Fix(BODY_FORCE_Z); -NODES[1986].Fix(BODY_FORCE_X); -NODES[1986].Fix(BODY_FORCE_Y); -NODES[1986].Fix(BODY_FORCE_Z); -NODES[1987].Fix(BODY_FORCE_X); -NODES[1987].Fix(BODY_FORCE_Y); -NODES[1987].Fix(BODY_FORCE_Z); -NODES[1988].Fix(BODY_FORCE_X); -NODES[1988].Fix(BODY_FORCE_Y); -NODES[1988].Fix(BODY_FORCE_Z); -NODES[1989].Fix(BODY_FORCE_X); -NODES[1989].Fix(BODY_FORCE_Y); -NODES[1989].Fix(BODY_FORCE_Z); -NODES[1990].Fix(BODY_FORCE_X); -NODES[1990].Fix(BODY_FORCE_Y); -NODES[1990].Fix(BODY_FORCE_Z); -NODES[1991].Fix(BODY_FORCE_X); -NODES[1991].Fix(BODY_FORCE_Y); -NODES[1991].Fix(BODY_FORCE_Z); -NODES[1992].Fix(BODY_FORCE_X); -NODES[1992].Fix(BODY_FORCE_Y); -NODES[1992].Fix(BODY_FORCE_Z); -NODES[1993].Fix(BODY_FORCE_X); -NODES[1993].Fix(BODY_FORCE_Y); -NODES[1993].Fix(BODY_FORCE_Z); -NODES[1994].Fix(BODY_FORCE_X); -NODES[1994].Fix(BODY_FORCE_Y); -NODES[1994].Fix(BODY_FORCE_Z); -NODES[1995].Fix(BODY_FORCE_X); -NODES[1995].Fix(BODY_FORCE_Y); -NODES[1995].Fix(BODY_FORCE_Z); -NODES[1996].Fix(BODY_FORCE_X); -NODES[1996].Fix(BODY_FORCE_Y); -NODES[1996].Fix(BODY_FORCE_Z); -NODES[1997].Fix(BODY_FORCE_X); -NODES[1997].Fix(BODY_FORCE_Y); -NODES[1997].Fix(BODY_FORCE_Z); -NODES[1998].Fix(BODY_FORCE_X); -NODES[1998].Fix(BODY_FORCE_Y); -NODES[1998].Fix(BODY_FORCE_Z); -NODES[1999].Fix(BODY_FORCE_X); -NODES[1999].Fix(BODY_FORCE_Y); -NODES[1999].Fix(BODY_FORCE_Z); -NODES[2000].Fix(BODY_FORCE_X); -NODES[2000].Fix(BODY_FORCE_Y); -NODES[2000].Fix(BODY_FORCE_Z); -NODES[2001].Fix(BODY_FORCE_X); -NODES[2001].Fix(BODY_FORCE_Y); -NODES[2001].Fix(BODY_FORCE_Z); -NODES[2002].Fix(BODY_FORCE_X); -NODES[2002].Fix(BODY_FORCE_Y); -NODES[2002].Fix(BODY_FORCE_Z); -NODES[2003].Fix(BODY_FORCE_X); -NODES[2003].Fix(BODY_FORCE_Y); -NODES[2003].Fix(BODY_FORCE_Z); -NODES[2004].Fix(BODY_FORCE_X); -NODES[2004].Fix(BODY_FORCE_Y); -NODES[2004].Fix(BODY_FORCE_Z); -NODES[2005].Fix(BODY_FORCE_X); -NODES[2005].Fix(BODY_FORCE_Y); -NODES[2005].Fix(BODY_FORCE_Z); -NODES[2006].Fix(BODY_FORCE_X); -NODES[2006].Fix(BODY_FORCE_Y); -NODES[2006].Fix(BODY_FORCE_Z); -NODES[2007].Fix(BODY_FORCE_X); -NODES[2007].Fix(BODY_FORCE_Y); -NODES[2007].Fix(BODY_FORCE_Z); -NODES[2008].Fix(BODY_FORCE_X); -NODES[2008].Fix(BODY_FORCE_Y); -NODES[2008].Fix(BODY_FORCE_Z); -NODES[2009].Fix(BODY_FORCE_X); -NODES[2009].Fix(BODY_FORCE_Y); -NODES[2009].Fix(BODY_FORCE_Z); -NODES[2011].Fix(BODY_FORCE_X); -NODES[2011].Fix(BODY_FORCE_Y); -NODES[2011].Fix(BODY_FORCE_Z); -NODES[2012].Fix(BODY_FORCE_X); -NODES[2012].Fix(BODY_FORCE_Y); -NODES[2012].Fix(BODY_FORCE_Z); -NODES[2013].Fix(BODY_FORCE_X); -NODES[2013].Fix(BODY_FORCE_Y); -NODES[2013].Fix(BODY_FORCE_Z); -NODES[2014].Fix(BODY_FORCE_X); -NODES[2014].Fix(BODY_FORCE_Y); -NODES[2014].Fix(BODY_FORCE_Z); -NODES[2015].Fix(BODY_FORCE_X); -NODES[2015].Fix(BODY_FORCE_Y); -NODES[2015].Fix(BODY_FORCE_Z); -NODES[2016].Fix(BODY_FORCE_X); -NODES[2016].Fix(BODY_FORCE_Y); -NODES[2016].Fix(BODY_FORCE_Z); -NODES[2017].Fix(BODY_FORCE_X); -NODES[2017].Fix(BODY_FORCE_Y); -NODES[2017].Fix(BODY_FORCE_Z); -NODES[2018].Fix(BODY_FORCE_X); -NODES[2018].Fix(BODY_FORCE_Y); -NODES[2018].Fix(BODY_FORCE_Z); -NODES[2019].Fix(BODY_FORCE_X); -NODES[2019].Fix(BODY_FORCE_Y); -NODES[2019].Fix(BODY_FORCE_Z); -NODES[2020].Fix(BODY_FORCE_X); -NODES[2020].Fix(BODY_FORCE_Y); -NODES[2020].Fix(BODY_FORCE_Z); -NODES[2021].Fix(BODY_FORCE_X); -NODES[2021].Fix(BODY_FORCE_Y); -NODES[2021].Fix(BODY_FORCE_Z); -NODES[2022].Fix(BODY_FORCE_X); -NODES[2022].Fix(BODY_FORCE_Y); -NODES[2022].Fix(BODY_FORCE_Z); -NODES[2023].Fix(BODY_FORCE_X); -NODES[2023].Fix(BODY_FORCE_Y); -NODES[2023].Fix(BODY_FORCE_Z); -NODES[2024].Fix(BODY_FORCE_X); -NODES[2024].Fix(BODY_FORCE_Y); -NODES[2024].Fix(BODY_FORCE_Z); -NODES[2025].Fix(BODY_FORCE_X); -NODES[2025].Fix(BODY_FORCE_Y); -NODES[2025].Fix(BODY_FORCE_Z); -NODES[2026].Fix(BODY_FORCE_X); -NODES[2026].Fix(BODY_FORCE_Y); -NODES[2026].Fix(BODY_FORCE_Z); -NODES[2027].Fix(BODY_FORCE_X); -NODES[2027].Fix(BODY_FORCE_Y); -NODES[2027].Fix(BODY_FORCE_Z); -NODES[2028].Fix(BODY_FORCE_X); -NODES[2028].Fix(BODY_FORCE_Y); -NODES[2028].Fix(BODY_FORCE_Z); -NODES[2029].Fix(BODY_FORCE_X); -NODES[2029].Fix(BODY_FORCE_Y); -NODES[2029].Fix(BODY_FORCE_Z); -NODES[2030].Fix(BODY_FORCE_X); -NODES[2030].Fix(BODY_FORCE_Y); -NODES[2030].Fix(BODY_FORCE_Z); -NODES[2031].Fix(BODY_FORCE_X); -NODES[2031].Fix(BODY_FORCE_Y); -NODES[2031].Fix(BODY_FORCE_Z); -NODES[2032].Fix(BODY_FORCE_X); -NODES[2032].Fix(BODY_FORCE_Y); -NODES[2032].Fix(BODY_FORCE_Z); -NODES[2033].Fix(BODY_FORCE_X); -NODES[2033].Fix(BODY_FORCE_Y); -NODES[2033].Fix(BODY_FORCE_Z); -NODES[2034].Fix(BODY_FORCE_X); -NODES[2034].Fix(BODY_FORCE_Y); -NODES[2034].Fix(BODY_FORCE_Z); -NODES[2035].Fix(BODY_FORCE_X); -NODES[2035].Fix(BODY_FORCE_Y); -NODES[2035].Fix(BODY_FORCE_Z); -NODES[2036].Fix(BODY_FORCE_X); -NODES[2036].Fix(BODY_FORCE_Y); -NODES[2036].Fix(BODY_FORCE_Z); -NODES[2037].Fix(BODY_FORCE_X); -NODES[2037].Fix(BODY_FORCE_Y); -NODES[2037].Fix(BODY_FORCE_Z); -NODES[2038].Fix(BODY_FORCE_X); -NODES[2038].Fix(BODY_FORCE_Y); -NODES[2038].Fix(BODY_FORCE_Z); -NODES[2039].Fix(BODY_FORCE_X); -NODES[2039].Fix(BODY_FORCE_Y); -NODES[2039].Fix(BODY_FORCE_Z); -NODES[2040].Fix(BODY_FORCE_X); -NODES[2040].Fix(BODY_FORCE_Y); -NODES[2040].Fix(BODY_FORCE_Z); -NODES[2041].Fix(BODY_FORCE_X); -NODES[2041].Fix(BODY_FORCE_Y); -NODES[2041].Fix(BODY_FORCE_Z); -NODES[2042].Fix(BODY_FORCE_X); -NODES[2042].Fix(BODY_FORCE_Y); -NODES[2042].Fix(BODY_FORCE_Z); -NODES[2044].Fix(BODY_FORCE_X); -NODES[2044].Fix(BODY_FORCE_Y); -NODES[2044].Fix(BODY_FORCE_Z); -NODES[2045].Fix(BODY_FORCE_X); -NODES[2045].Fix(BODY_FORCE_Y); -NODES[2045].Fix(BODY_FORCE_Z); -NODES[2046].Fix(BODY_FORCE_X); -NODES[2046].Fix(BODY_FORCE_Y); -NODES[2046].Fix(BODY_FORCE_Z); -NODES[2047].Fix(BODY_FORCE_X); -NODES[2047].Fix(BODY_FORCE_Y); -NODES[2047].Fix(BODY_FORCE_Z); -NODES[2048].Fix(BODY_FORCE_X); -NODES[2048].Fix(BODY_FORCE_Y); -NODES[2048].Fix(BODY_FORCE_Z); -NODES[2049].Fix(BODY_FORCE_X); -NODES[2049].Fix(BODY_FORCE_Y); -NODES[2049].Fix(BODY_FORCE_Z); -NODES[2050].Fix(BODY_FORCE_X); -NODES[2050].Fix(BODY_FORCE_Y); -NODES[2050].Fix(BODY_FORCE_Z); -NODES[2051].Fix(BODY_FORCE_X); -NODES[2051].Fix(BODY_FORCE_Y); -NODES[2051].Fix(BODY_FORCE_Z); -NODES[2052].Fix(BODY_FORCE_X); -NODES[2052].Fix(BODY_FORCE_Y); -NODES[2052].Fix(BODY_FORCE_Z); -NODES[2053].Fix(BODY_FORCE_X); -NODES[2053].Fix(BODY_FORCE_Y); -NODES[2053].Fix(BODY_FORCE_Z); -NODES[2054].Fix(BODY_FORCE_X); -NODES[2054].Fix(BODY_FORCE_Y); -NODES[2054].Fix(BODY_FORCE_Z); -NODES[2055].Fix(BODY_FORCE_X); -NODES[2055].Fix(BODY_FORCE_Y); -NODES[2055].Fix(BODY_FORCE_Z); -NODES[2056].Fix(BODY_FORCE_X); -NODES[2056].Fix(BODY_FORCE_Y); -NODES[2056].Fix(BODY_FORCE_Z); -NODES[2057].Fix(BODY_FORCE_X); -NODES[2057].Fix(BODY_FORCE_Y); -NODES[2057].Fix(BODY_FORCE_Z); -NODES[2058].Fix(BODY_FORCE_X); -NODES[2058].Fix(BODY_FORCE_Y); -NODES[2058].Fix(BODY_FORCE_Z); -NODES[2059].Fix(BODY_FORCE_X); -NODES[2059].Fix(BODY_FORCE_Y); -NODES[2059].Fix(BODY_FORCE_Z); -NODES[2060].Fix(BODY_FORCE_X); -NODES[2060].Fix(BODY_FORCE_Y); -NODES[2060].Fix(BODY_FORCE_Z); -NODES[2061].Fix(BODY_FORCE_X); -NODES[2061].Fix(BODY_FORCE_Y); -NODES[2061].Fix(BODY_FORCE_Z); -NODES[2062].Fix(BODY_FORCE_X); -NODES[2062].Fix(BODY_FORCE_Y); -NODES[2062].Fix(BODY_FORCE_Z); -NODES[2063].Fix(BODY_FORCE_X); -NODES[2063].Fix(BODY_FORCE_Y); -NODES[2063].Fix(BODY_FORCE_Z); -NODES[2064].Fix(BODY_FORCE_X); -NODES[2064].Fix(BODY_FORCE_Y); -NODES[2064].Fix(BODY_FORCE_Z); -NODES[2065].Fix(BODY_FORCE_X); -NODES[2065].Fix(BODY_FORCE_Y); -NODES[2065].Fix(BODY_FORCE_Z); -NODES[2066].Fix(BODY_FORCE_X); -NODES[2066].Fix(BODY_FORCE_Y); -NODES[2066].Fix(BODY_FORCE_Z); -NODES[2067].Fix(BODY_FORCE_X); -NODES[2067].Fix(BODY_FORCE_Y); -NODES[2067].Fix(BODY_FORCE_Z); -NODES[2068].Fix(BODY_FORCE_X); -NODES[2068].Fix(BODY_FORCE_Y); -NODES[2068].Fix(BODY_FORCE_Z); -NODES[2069].Fix(BODY_FORCE_X); -NODES[2069].Fix(BODY_FORCE_Y); -NODES[2069].Fix(BODY_FORCE_Z); -NODES[2070].Fix(BODY_FORCE_X); -NODES[2070].Fix(BODY_FORCE_Y); -NODES[2070].Fix(BODY_FORCE_Z); -NODES[2071].Fix(BODY_FORCE_X); -NODES[2071].Fix(BODY_FORCE_Y); -NODES[2071].Fix(BODY_FORCE_Z); -NODES[2072].Fix(BODY_FORCE_X); -NODES[2072].Fix(BODY_FORCE_Y); -NODES[2072].Fix(BODY_FORCE_Z); -NODES[2073].Fix(BODY_FORCE_X); -NODES[2073].Fix(BODY_FORCE_Y); -NODES[2073].Fix(BODY_FORCE_Z); -NODES[2074].Fix(BODY_FORCE_X); -NODES[2074].Fix(BODY_FORCE_Y); -NODES[2074].Fix(BODY_FORCE_Z); -NODES[2075].Fix(BODY_FORCE_X); -NODES[2075].Fix(BODY_FORCE_Y); -NODES[2075].Fix(BODY_FORCE_Z); -NODES[2076].Fix(BODY_FORCE_X); -NODES[2076].Fix(BODY_FORCE_Y); -NODES[2076].Fix(BODY_FORCE_Z); -NODES[2078].Fix(BODY_FORCE_X); -NODES[2078].Fix(BODY_FORCE_Y); -NODES[2078].Fix(BODY_FORCE_Z); -NODES[2079].Fix(BODY_FORCE_X); -NODES[2079].Fix(BODY_FORCE_Y); -NODES[2079].Fix(BODY_FORCE_Z); -NODES[2080].Fix(BODY_FORCE_X); -NODES[2080].Fix(BODY_FORCE_Y); -NODES[2080].Fix(BODY_FORCE_Z); -NODES[2081].Fix(BODY_FORCE_X); -NODES[2081].Fix(BODY_FORCE_Y); -NODES[2081].Fix(BODY_FORCE_Z); -NODES[2082].Fix(BODY_FORCE_X); -NODES[2082].Fix(BODY_FORCE_Y); -NODES[2082].Fix(BODY_FORCE_Z); -NODES[2083].Fix(BODY_FORCE_X); -NODES[2083].Fix(BODY_FORCE_Y); -NODES[2083].Fix(BODY_FORCE_Z); -NODES[2084].Fix(BODY_FORCE_X); -NODES[2084].Fix(BODY_FORCE_Y); -NODES[2084].Fix(BODY_FORCE_Z); -NODES[2085].Fix(BODY_FORCE_X); -NODES[2085].Fix(BODY_FORCE_Y); -NODES[2085].Fix(BODY_FORCE_Z); -NODES[2086].Fix(BODY_FORCE_X); -NODES[2086].Fix(BODY_FORCE_Y); -NODES[2086].Fix(BODY_FORCE_Z); -NODES[2087].Fix(BODY_FORCE_X); -NODES[2087].Fix(BODY_FORCE_Y); -NODES[2087].Fix(BODY_FORCE_Z); -NODES[2088].Fix(BODY_FORCE_X); -NODES[2088].Fix(BODY_FORCE_Y); -NODES[2088].Fix(BODY_FORCE_Z); -NODES[2089].Fix(BODY_FORCE_X); -NODES[2089].Fix(BODY_FORCE_Y); -NODES[2089].Fix(BODY_FORCE_Z); -NODES[2090].Fix(BODY_FORCE_X); -NODES[2090].Fix(BODY_FORCE_Y); -NODES[2090].Fix(BODY_FORCE_Z); -NODES[2091].Fix(BODY_FORCE_X); -NODES[2091].Fix(BODY_FORCE_Y); -NODES[2091].Fix(BODY_FORCE_Z); -NODES[2092].Fix(BODY_FORCE_X); -NODES[2092].Fix(BODY_FORCE_Y); -NODES[2092].Fix(BODY_FORCE_Z); -NODES[2093].Fix(BODY_FORCE_X); -NODES[2093].Fix(BODY_FORCE_Y); -NODES[2093].Fix(BODY_FORCE_Z); -NODES[2094].Fix(BODY_FORCE_X); -NODES[2094].Fix(BODY_FORCE_Y); -NODES[2094].Fix(BODY_FORCE_Z); -NODES[2095].Fix(BODY_FORCE_X); -NODES[2095].Fix(BODY_FORCE_Y); -NODES[2095].Fix(BODY_FORCE_Z); -NODES[2096].Fix(BODY_FORCE_X); -NODES[2096].Fix(BODY_FORCE_Y); -NODES[2096].Fix(BODY_FORCE_Z); -NODES[2097].Fix(BODY_FORCE_X); -NODES[2097].Fix(BODY_FORCE_Y); -NODES[2097].Fix(BODY_FORCE_Z); -NODES[2098].Fix(BODY_FORCE_X); -NODES[2098].Fix(BODY_FORCE_Y); -NODES[2098].Fix(BODY_FORCE_Z); -NODES[2099].Fix(BODY_FORCE_X); -NODES[2099].Fix(BODY_FORCE_Y); -NODES[2099].Fix(BODY_FORCE_Z); -NODES[2100].Fix(BODY_FORCE_X); -NODES[2100].Fix(BODY_FORCE_Y); -NODES[2100].Fix(BODY_FORCE_Z); -NODES[2101].Fix(BODY_FORCE_X); -NODES[2101].Fix(BODY_FORCE_Y); -NODES[2101].Fix(BODY_FORCE_Z); -NODES[2102].Fix(BODY_FORCE_X); -NODES[2102].Fix(BODY_FORCE_Y); -NODES[2102].Fix(BODY_FORCE_Z); -NODES[2103].Fix(BODY_FORCE_X); -NODES[2103].Fix(BODY_FORCE_Y); -NODES[2103].Fix(BODY_FORCE_Z); -NODES[2104].Fix(BODY_FORCE_X); -NODES[2104].Fix(BODY_FORCE_Y); -NODES[2104].Fix(BODY_FORCE_Z); -NODES[2105].Fix(BODY_FORCE_X); -NODES[2105].Fix(BODY_FORCE_Y); -NODES[2105].Fix(BODY_FORCE_Z); -NODES[2106].Fix(BODY_FORCE_X); -NODES[2106].Fix(BODY_FORCE_Y); -NODES[2106].Fix(BODY_FORCE_Z); -NODES[2107].Fix(BODY_FORCE_X); -NODES[2107].Fix(BODY_FORCE_Y); -NODES[2107].Fix(BODY_FORCE_Z); -NODES[2108].Fix(BODY_FORCE_X); -NODES[2108].Fix(BODY_FORCE_Y); -NODES[2108].Fix(BODY_FORCE_Z); -NODES[2109].Fix(BODY_FORCE_X); -NODES[2109].Fix(BODY_FORCE_Y); -NODES[2109].Fix(BODY_FORCE_Z); -NODES[2111].Fix(BODY_FORCE_X); -NODES[2111].Fix(BODY_FORCE_Y); -NODES[2111].Fix(BODY_FORCE_Z); -NODES[2112].Fix(BODY_FORCE_X); -NODES[2112].Fix(BODY_FORCE_Y); -NODES[2112].Fix(BODY_FORCE_Z); -NODES[2113].Fix(BODY_FORCE_X); -NODES[2113].Fix(BODY_FORCE_Y); -NODES[2113].Fix(BODY_FORCE_Z); -NODES[2114].Fix(BODY_FORCE_X); -NODES[2114].Fix(BODY_FORCE_Y); -NODES[2114].Fix(BODY_FORCE_Z); -NODES[2115].Fix(BODY_FORCE_X); -NODES[2115].Fix(BODY_FORCE_Y); -NODES[2115].Fix(BODY_FORCE_Z); -NODES[2116].Fix(BODY_FORCE_X); -NODES[2116].Fix(BODY_FORCE_Y); -NODES[2116].Fix(BODY_FORCE_Z); -NODES[2117].Fix(BODY_FORCE_X); -NODES[2117].Fix(BODY_FORCE_Y); -NODES[2117].Fix(BODY_FORCE_Z); -NODES[2118].Fix(BODY_FORCE_X); -NODES[2118].Fix(BODY_FORCE_Y); -NODES[2118].Fix(BODY_FORCE_Z); -NODES[2119].Fix(BODY_FORCE_X); -NODES[2119].Fix(BODY_FORCE_Y); -NODES[2119].Fix(BODY_FORCE_Z); -NODES[2120].Fix(BODY_FORCE_X); -NODES[2120].Fix(BODY_FORCE_Y); -NODES[2120].Fix(BODY_FORCE_Z); -NODES[2121].Fix(BODY_FORCE_X); -NODES[2121].Fix(BODY_FORCE_Y); -NODES[2121].Fix(BODY_FORCE_Z); -NODES[2122].Fix(BODY_FORCE_X); -NODES[2122].Fix(BODY_FORCE_Y); -NODES[2122].Fix(BODY_FORCE_Z); -NODES[2123].Fix(BODY_FORCE_X); -NODES[2123].Fix(BODY_FORCE_Y); -NODES[2123].Fix(BODY_FORCE_Z); -NODES[2124].Fix(BODY_FORCE_X); -NODES[2124].Fix(BODY_FORCE_Y); -NODES[2124].Fix(BODY_FORCE_Z); -NODES[2125].Fix(BODY_FORCE_X); -NODES[2125].Fix(BODY_FORCE_Y); -NODES[2125].Fix(BODY_FORCE_Z); -NODES[2126].Fix(BODY_FORCE_X); -NODES[2126].Fix(BODY_FORCE_Y); -NODES[2126].Fix(BODY_FORCE_Z); -NODES[2127].Fix(BODY_FORCE_X); -NODES[2127].Fix(BODY_FORCE_Y); -NODES[2127].Fix(BODY_FORCE_Z); -NODES[2128].Fix(BODY_FORCE_X); -NODES[2128].Fix(BODY_FORCE_Y); -NODES[2128].Fix(BODY_FORCE_Z); -NODES[2129].Fix(BODY_FORCE_X); -NODES[2129].Fix(BODY_FORCE_Y); -NODES[2129].Fix(BODY_FORCE_Z); -NODES[2130].Fix(BODY_FORCE_X); -NODES[2130].Fix(BODY_FORCE_Y); -NODES[2130].Fix(BODY_FORCE_Z); -NODES[2131].Fix(BODY_FORCE_X); -NODES[2131].Fix(BODY_FORCE_Y); -NODES[2131].Fix(BODY_FORCE_Z); -NODES[2132].Fix(BODY_FORCE_X); -NODES[2132].Fix(BODY_FORCE_Y); -NODES[2132].Fix(BODY_FORCE_Z); -NODES[2133].Fix(BODY_FORCE_X); -NODES[2133].Fix(BODY_FORCE_Y); -NODES[2133].Fix(BODY_FORCE_Z); -NODES[2134].Fix(BODY_FORCE_X); -NODES[2134].Fix(BODY_FORCE_Y); -NODES[2134].Fix(BODY_FORCE_Z); -NODES[2135].Fix(BODY_FORCE_X); -NODES[2135].Fix(BODY_FORCE_Y); -NODES[2135].Fix(BODY_FORCE_Z); -NODES[2136].Fix(BODY_FORCE_X); -NODES[2136].Fix(BODY_FORCE_Y); -NODES[2136].Fix(BODY_FORCE_Z); -NODES[2137].Fix(BODY_FORCE_X); -NODES[2137].Fix(BODY_FORCE_Y); -NODES[2137].Fix(BODY_FORCE_Z); -NODES[2138].Fix(BODY_FORCE_X); -NODES[2138].Fix(BODY_FORCE_Y); -NODES[2138].Fix(BODY_FORCE_Z); -NODES[2139].Fix(BODY_FORCE_X); -NODES[2139].Fix(BODY_FORCE_Y); -NODES[2139].Fix(BODY_FORCE_Z); -NODES[2140].Fix(BODY_FORCE_X); -NODES[2140].Fix(BODY_FORCE_Y); -NODES[2140].Fix(BODY_FORCE_Z); -NODES[2141].Fix(BODY_FORCE_X); -NODES[2141].Fix(BODY_FORCE_Y); -NODES[2141].Fix(BODY_FORCE_Z); -NODES[2142].Fix(BODY_FORCE_X); -NODES[2142].Fix(BODY_FORCE_Y); -NODES[2142].Fix(BODY_FORCE_Z); -NODES[2144].Fix(BODY_FORCE_X); -NODES[2144].Fix(BODY_FORCE_Y); -NODES[2144].Fix(BODY_FORCE_Z); -NODES[2145].Fix(BODY_FORCE_X); -NODES[2145].Fix(BODY_FORCE_Y); -NODES[2145].Fix(BODY_FORCE_Z); -NODES[2146].Fix(BODY_FORCE_X); -NODES[2146].Fix(BODY_FORCE_Y); -NODES[2146].Fix(BODY_FORCE_Z); -NODES[2147].Fix(BODY_FORCE_X); -NODES[2147].Fix(BODY_FORCE_Y); -NODES[2147].Fix(BODY_FORCE_Z); -NODES[2148].Fix(BODY_FORCE_X); -NODES[2148].Fix(BODY_FORCE_Y); -NODES[2148].Fix(BODY_FORCE_Z); -NODES[2149].Fix(BODY_FORCE_X); -NODES[2149].Fix(BODY_FORCE_Y); -NODES[2149].Fix(BODY_FORCE_Z); -NODES[2150].Fix(BODY_FORCE_X); -NODES[2150].Fix(BODY_FORCE_Y); -NODES[2150].Fix(BODY_FORCE_Z); -NODES[2151].Fix(BODY_FORCE_X); -NODES[2151].Fix(BODY_FORCE_Y); -NODES[2151].Fix(BODY_FORCE_Z); -NODES[2152].Fix(BODY_FORCE_X); -NODES[2152].Fix(BODY_FORCE_Y); -NODES[2152].Fix(BODY_FORCE_Z); -NODES[2153].Fix(BODY_FORCE_X); -NODES[2153].Fix(BODY_FORCE_Y); -NODES[2153].Fix(BODY_FORCE_Z); -NODES[2154].Fix(BODY_FORCE_X); -NODES[2154].Fix(BODY_FORCE_Y); -NODES[2154].Fix(BODY_FORCE_Z); -NODES[2155].Fix(BODY_FORCE_X); -NODES[2155].Fix(BODY_FORCE_Y); -NODES[2155].Fix(BODY_FORCE_Z); -NODES[2156].Fix(BODY_FORCE_X); -NODES[2156].Fix(BODY_FORCE_Y); -NODES[2156].Fix(BODY_FORCE_Z); -NODES[2157].Fix(BODY_FORCE_X); -NODES[2157].Fix(BODY_FORCE_Y); -NODES[2157].Fix(BODY_FORCE_Z); -NODES[2158].Fix(BODY_FORCE_X); -NODES[2158].Fix(BODY_FORCE_Y); -NODES[2158].Fix(BODY_FORCE_Z); -NODES[2159].Fix(BODY_FORCE_X); -NODES[2159].Fix(BODY_FORCE_Y); -NODES[2159].Fix(BODY_FORCE_Z); -NODES[2160].Fix(BODY_FORCE_X); -NODES[2160].Fix(BODY_FORCE_Y); -NODES[2160].Fix(BODY_FORCE_Z); -NODES[2161].Fix(BODY_FORCE_X); -NODES[2161].Fix(BODY_FORCE_Y); -NODES[2161].Fix(BODY_FORCE_Z); -NODES[2162].Fix(BODY_FORCE_X); -NODES[2162].Fix(BODY_FORCE_Y); -NODES[2162].Fix(BODY_FORCE_Z); -NODES[2163].Fix(BODY_FORCE_X); -NODES[2163].Fix(BODY_FORCE_Y); -NODES[2163].Fix(BODY_FORCE_Z); -NODES[2164].Fix(BODY_FORCE_X); -NODES[2164].Fix(BODY_FORCE_Y); -NODES[2164].Fix(BODY_FORCE_Z); -NODES[2165].Fix(BODY_FORCE_X); -NODES[2165].Fix(BODY_FORCE_Y); -NODES[2165].Fix(BODY_FORCE_Z); -NODES[2166].Fix(BODY_FORCE_X); -NODES[2166].Fix(BODY_FORCE_Y); -NODES[2166].Fix(BODY_FORCE_Z); -NODES[2167].Fix(BODY_FORCE_X); -NODES[2167].Fix(BODY_FORCE_Y); -NODES[2167].Fix(BODY_FORCE_Z); -NODES[2168].Fix(BODY_FORCE_X); -NODES[2168].Fix(BODY_FORCE_Y); -NODES[2168].Fix(BODY_FORCE_Z); -NODES[2169].Fix(BODY_FORCE_X); -NODES[2169].Fix(BODY_FORCE_Y); -NODES[2169].Fix(BODY_FORCE_Z); -NODES[2170].Fix(BODY_FORCE_X); -NODES[2170].Fix(BODY_FORCE_Y); -NODES[2170].Fix(BODY_FORCE_Z); -NODES[2171].Fix(BODY_FORCE_X); -NODES[2171].Fix(BODY_FORCE_Y); -NODES[2171].Fix(BODY_FORCE_Z); -NODES[2172].Fix(BODY_FORCE_X); -NODES[2172].Fix(BODY_FORCE_Y); -NODES[2172].Fix(BODY_FORCE_Z); -NODES[2173].Fix(BODY_FORCE_X); -NODES[2173].Fix(BODY_FORCE_Y); -NODES[2173].Fix(BODY_FORCE_Z); -NODES[2174].Fix(BODY_FORCE_X); -NODES[2174].Fix(BODY_FORCE_Y); -NODES[2174].Fix(BODY_FORCE_Z); -NODES[2175].Fix(BODY_FORCE_X); -NODES[2175].Fix(BODY_FORCE_Y); -NODES[2175].Fix(BODY_FORCE_Z); -NODES[2177].Fix(BODY_FORCE_X); -NODES[2177].Fix(BODY_FORCE_Y); -NODES[2177].Fix(BODY_FORCE_Z); -NODES[2178].Fix(BODY_FORCE_X); -NODES[2178].Fix(BODY_FORCE_Y); -NODES[2178].Fix(BODY_FORCE_Z); -NODES[2179].Fix(BODY_FORCE_X); -NODES[2179].Fix(BODY_FORCE_Y); -NODES[2179].Fix(BODY_FORCE_Z); -NODES[2180].Fix(BODY_FORCE_X); -NODES[2180].Fix(BODY_FORCE_Y); -NODES[2180].Fix(BODY_FORCE_Z); -NODES[2181].Fix(BODY_FORCE_X); -NODES[2181].Fix(BODY_FORCE_Y); -NODES[2181].Fix(BODY_FORCE_Z); -NODES[2182].Fix(BODY_FORCE_X); -NODES[2182].Fix(BODY_FORCE_Y); -NODES[2182].Fix(BODY_FORCE_Z); -NODES[2183].Fix(BODY_FORCE_X); -NODES[2183].Fix(BODY_FORCE_Y); -NODES[2183].Fix(BODY_FORCE_Z); -NODES[2184].Fix(BODY_FORCE_X); -NODES[2184].Fix(BODY_FORCE_Y); -NODES[2184].Fix(BODY_FORCE_Z); -NODES[2185].Fix(BODY_FORCE_X); -NODES[2185].Fix(BODY_FORCE_Y); -NODES[2185].Fix(BODY_FORCE_Z); -NODES[2186].Fix(BODY_FORCE_X); -NODES[2186].Fix(BODY_FORCE_Y); -NODES[2186].Fix(BODY_FORCE_Z); -NODES[2187].Fix(BODY_FORCE_X); -NODES[2187].Fix(BODY_FORCE_Y); -NODES[2187].Fix(BODY_FORCE_Z); -NODES[2188].Fix(BODY_FORCE_X); -NODES[2188].Fix(BODY_FORCE_Y); -NODES[2188].Fix(BODY_FORCE_Z); -NODES[2189].Fix(BODY_FORCE_X); -NODES[2189].Fix(BODY_FORCE_Y); -NODES[2189].Fix(BODY_FORCE_Z); -NODES[2190].Fix(BODY_FORCE_X); -NODES[2190].Fix(BODY_FORCE_Y); -NODES[2190].Fix(BODY_FORCE_Z); -NODES[2191].Fix(BODY_FORCE_X); -NODES[2191].Fix(BODY_FORCE_Y); -NODES[2191].Fix(BODY_FORCE_Z); -NODES[2192].Fix(BODY_FORCE_X); -NODES[2192].Fix(BODY_FORCE_Y); -NODES[2192].Fix(BODY_FORCE_Z); -NODES[2193].Fix(BODY_FORCE_X); -NODES[2193].Fix(BODY_FORCE_Y); -NODES[2193].Fix(BODY_FORCE_Z); -NODES[2194].Fix(BODY_FORCE_X); -NODES[2194].Fix(BODY_FORCE_Y); -NODES[2194].Fix(BODY_FORCE_Z); -NODES[2195].Fix(BODY_FORCE_X); -NODES[2195].Fix(BODY_FORCE_Y); -NODES[2195].Fix(BODY_FORCE_Z); -NODES[2196].Fix(BODY_FORCE_X); -NODES[2196].Fix(BODY_FORCE_Y); -NODES[2196].Fix(BODY_FORCE_Z); -NODES[2197].Fix(BODY_FORCE_X); -NODES[2197].Fix(BODY_FORCE_Y); -NODES[2197].Fix(BODY_FORCE_Z); -NODES[2198].Fix(BODY_FORCE_X); -NODES[2198].Fix(BODY_FORCE_Y); -NODES[2198].Fix(BODY_FORCE_Z); -NODES[2199].Fix(BODY_FORCE_X); -NODES[2199].Fix(BODY_FORCE_Y); -NODES[2199].Fix(BODY_FORCE_Z); -NODES[2200].Fix(BODY_FORCE_X); -NODES[2200].Fix(BODY_FORCE_Y); -NODES[2200].Fix(BODY_FORCE_Z); -NODES[2201].Fix(BODY_FORCE_X); -NODES[2201].Fix(BODY_FORCE_Y); -NODES[2201].Fix(BODY_FORCE_Z); -NODES[2202].Fix(BODY_FORCE_X); -NODES[2202].Fix(BODY_FORCE_Y); -NODES[2202].Fix(BODY_FORCE_Z); -NODES[2203].Fix(BODY_FORCE_X); -NODES[2203].Fix(BODY_FORCE_Y); -NODES[2203].Fix(BODY_FORCE_Z); -NODES[2204].Fix(BODY_FORCE_X); -NODES[2204].Fix(BODY_FORCE_Y); -NODES[2204].Fix(BODY_FORCE_Z); -NODES[2205].Fix(BODY_FORCE_X); -NODES[2205].Fix(BODY_FORCE_Y); -NODES[2205].Fix(BODY_FORCE_Z); -NODES[2206].Fix(BODY_FORCE_X); -NODES[2206].Fix(BODY_FORCE_Y); -NODES[2206].Fix(BODY_FORCE_Z); -NODES[2207].Fix(BODY_FORCE_X); -NODES[2207].Fix(BODY_FORCE_Y); -NODES[2207].Fix(BODY_FORCE_Z); -NODES[2209].Fix(BODY_FORCE_X); -NODES[2209].Fix(BODY_FORCE_Y); -NODES[2209].Fix(BODY_FORCE_Z); -NODES[2210].Fix(BODY_FORCE_X); -NODES[2210].Fix(BODY_FORCE_Y); -NODES[2210].Fix(BODY_FORCE_Z); -NODES[2211].Fix(BODY_FORCE_X); -NODES[2211].Fix(BODY_FORCE_Y); -NODES[2211].Fix(BODY_FORCE_Z); -NODES[2212].Fix(BODY_FORCE_X); -NODES[2212].Fix(BODY_FORCE_Y); -NODES[2212].Fix(BODY_FORCE_Z); -NODES[2213].Fix(BODY_FORCE_X); -NODES[2213].Fix(BODY_FORCE_Y); -NODES[2213].Fix(BODY_FORCE_Z); -NODES[2214].Fix(BODY_FORCE_X); -NODES[2214].Fix(BODY_FORCE_Y); -NODES[2214].Fix(BODY_FORCE_Z); -NODES[2215].Fix(BODY_FORCE_X); -NODES[2215].Fix(BODY_FORCE_Y); -NODES[2215].Fix(BODY_FORCE_Z); -NODES[2216].Fix(BODY_FORCE_X); -NODES[2216].Fix(BODY_FORCE_Y); -NODES[2216].Fix(BODY_FORCE_Z); -NODES[2217].Fix(BODY_FORCE_X); -NODES[2217].Fix(BODY_FORCE_Y); -NODES[2217].Fix(BODY_FORCE_Z); -NODES[2218].Fix(BODY_FORCE_X); -NODES[2218].Fix(BODY_FORCE_Y); -NODES[2218].Fix(BODY_FORCE_Z); -NODES[2219].Fix(BODY_FORCE_X); -NODES[2219].Fix(BODY_FORCE_Y); -NODES[2219].Fix(BODY_FORCE_Z); -NODES[2220].Fix(BODY_FORCE_X); -NODES[2220].Fix(BODY_FORCE_Y); -NODES[2220].Fix(BODY_FORCE_Z); -NODES[2221].Fix(BODY_FORCE_X); -NODES[2221].Fix(BODY_FORCE_Y); -NODES[2221].Fix(BODY_FORCE_Z); -NODES[2222].Fix(BODY_FORCE_X); -NODES[2222].Fix(BODY_FORCE_Y); -NODES[2222].Fix(BODY_FORCE_Z); -NODES[2223].Fix(BODY_FORCE_X); -NODES[2223].Fix(BODY_FORCE_Y); -NODES[2223].Fix(BODY_FORCE_Z); -NODES[2224].Fix(BODY_FORCE_X); -NODES[2224].Fix(BODY_FORCE_Y); -NODES[2224].Fix(BODY_FORCE_Z); -NODES[2225].Fix(BODY_FORCE_X); -NODES[2225].Fix(BODY_FORCE_Y); -NODES[2225].Fix(BODY_FORCE_Z); -NODES[2226].Fix(BODY_FORCE_X); -NODES[2226].Fix(BODY_FORCE_Y); -NODES[2226].Fix(BODY_FORCE_Z); -NODES[2227].Fix(BODY_FORCE_X); -NODES[2227].Fix(BODY_FORCE_Y); -NODES[2227].Fix(BODY_FORCE_Z); -NODES[2228].Fix(BODY_FORCE_X); -NODES[2228].Fix(BODY_FORCE_Y); -NODES[2228].Fix(BODY_FORCE_Z); -NODES[2229].Fix(BODY_FORCE_X); -NODES[2229].Fix(BODY_FORCE_Y); -NODES[2229].Fix(BODY_FORCE_Z); -NODES[2230].Fix(BODY_FORCE_X); -NODES[2230].Fix(BODY_FORCE_Y); -NODES[2230].Fix(BODY_FORCE_Z); -NODES[2231].Fix(BODY_FORCE_X); -NODES[2231].Fix(BODY_FORCE_Y); -NODES[2231].Fix(BODY_FORCE_Z); -NODES[2232].Fix(BODY_FORCE_X); -NODES[2232].Fix(BODY_FORCE_Y); -NODES[2232].Fix(BODY_FORCE_Z); -NODES[2233].Fix(BODY_FORCE_X); -NODES[2233].Fix(BODY_FORCE_Y); -NODES[2233].Fix(BODY_FORCE_Z); -NODES[2234].Fix(BODY_FORCE_X); -NODES[2234].Fix(BODY_FORCE_Y); -NODES[2234].Fix(BODY_FORCE_Z); -NODES[2235].Fix(BODY_FORCE_X); -NODES[2235].Fix(BODY_FORCE_Y); -NODES[2235].Fix(BODY_FORCE_Z); -NODES[2236].Fix(BODY_FORCE_X); -NODES[2236].Fix(BODY_FORCE_Y); -NODES[2236].Fix(BODY_FORCE_Z); -NODES[2237].Fix(BODY_FORCE_X); -NODES[2237].Fix(BODY_FORCE_Y); -NODES[2237].Fix(BODY_FORCE_Z); -NODES[2238].Fix(BODY_FORCE_X); -NODES[2238].Fix(BODY_FORCE_Y); -NODES[2238].Fix(BODY_FORCE_Z); -NODES[2239].Fix(BODY_FORCE_X); -NODES[2239].Fix(BODY_FORCE_Y); -NODES[2239].Fix(BODY_FORCE_Z); -NODES[2241].Fix(BODY_FORCE_X); -NODES[2241].Fix(BODY_FORCE_Y); -NODES[2241].Fix(BODY_FORCE_Z); -NODES[2242].Fix(BODY_FORCE_X); -NODES[2242].Fix(BODY_FORCE_Y); -NODES[2242].Fix(BODY_FORCE_Z); -NODES[2243].Fix(BODY_FORCE_X); -NODES[2243].Fix(BODY_FORCE_Y); -NODES[2243].Fix(BODY_FORCE_Z); -NODES[2244].Fix(BODY_FORCE_X); -NODES[2244].Fix(BODY_FORCE_Y); -NODES[2244].Fix(BODY_FORCE_Z); -NODES[2245].Fix(BODY_FORCE_X); -NODES[2245].Fix(BODY_FORCE_Y); -NODES[2245].Fix(BODY_FORCE_Z); -NODES[2246].Fix(BODY_FORCE_X); -NODES[2246].Fix(BODY_FORCE_Y); -NODES[2246].Fix(BODY_FORCE_Z); -NODES[2247].Fix(BODY_FORCE_X); -NODES[2247].Fix(BODY_FORCE_Y); -NODES[2247].Fix(BODY_FORCE_Z); -NODES[2248].Fix(BODY_FORCE_X); -NODES[2248].Fix(BODY_FORCE_Y); -NODES[2248].Fix(BODY_FORCE_Z); -NODES[2249].Fix(BODY_FORCE_X); -NODES[2249].Fix(BODY_FORCE_Y); -NODES[2249].Fix(BODY_FORCE_Z); -NODES[2250].Fix(BODY_FORCE_X); -NODES[2250].Fix(BODY_FORCE_Y); -NODES[2250].Fix(BODY_FORCE_Z); -NODES[2251].Fix(BODY_FORCE_X); -NODES[2251].Fix(BODY_FORCE_Y); -NODES[2251].Fix(BODY_FORCE_Z); -NODES[2252].Fix(BODY_FORCE_X); -NODES[2252].Fix(BODY_FORCE_Y); -NODES[2252].Fix(BODY_FORCE_Z); -NODES[2253].Fix(BODY_FORCE_X); -NODES[2253].Fix(BODY_FORCE_Y); -NODES[2253].Fix(BODY_FORCE_Z); -NODES[2254].Fix(BODY_FORCE_X); -NODES[2254].Fix(BODY_FORCE_Y); -NODES[2254].Fix(BODY_FORCE_Z); -NODES[2255].Fix(BODY_FORCE_X); -NODES[2255].Fix(BODY_FORCE_Y); -NODES[2255].Fix(BODY_FORCE_Z); -NODES[2256].Fix(BODY_FORCE_X); -NODES[2256].Fix(BODY_FORCE_Y); -NODES[2256].Fix(BODY_FORCE_Z); -NODES[2257].Fix(BODY_FORCE_X); -NODES[2257].Fix(BODY_FORCE_Y); -NODES[2257].Fix(BODY_FORCE_Z); -NODES[2258].Fix(BODY_FORCE_X); -NODES[2258].Fix(BODY_FORCE_Y); -NODES[2258].Fix(BODY_FORCE_Z); -NODES[2259].Fix(BODY_FORCE_X); -NODES[2259].Fix(BODY_FORCE_Y); -NODES[2259].Fix(BODY_FORCE_Z); -NODES[2260].Fix(BODY_FORCE_X); -NODES[2260].Fix(BODY_FORCE_Y); -NODES[2260].Fix(BODY_FORCE_Z); -NODES[2261].Fix(BODY_FORCE_X); -NODES[2261].Fix(BODY_FORCE_Y); -NODES[2261].Fix(BODY_FORCE_Z); -NODES[2262].Fix(BODY_FORCE_X); -NODES[2262].Fix(BODY_FORCE_Y); -NODES[2262].Fix(BODY_FORCE_Z); -NODES[2263].Fix(BODY_FORCE_X); -NODES[2263].Fix(BODY_FORCE_Y); -NODES[2263].Fix(BODY_FORCE_Z); -NODES[2264].Fix(BODY_FORCE_X); -NODES[2264].Fix(BODY_FORCE_Y); -NODES[2264].Fix(BODY_FORCE_Z); -NODES[2265].Fix(BODY_FORCE_X); -NODES[2265].Fix(BODY_FORCE_Y); -NODES[2265].Fix(BODY_FORCE_Z); -NODES[2266].Fix(BODY_FORCE_X); -NODES[2266].Fix(BODY_FORCE_Y); -NODES[2266].Fix(BODY_FORCE_Z); -NODES[2267].Fix(BODY_FORCE_X); -NODES[2267].Fix(BODY_FORCE_Y); -NODES[2267].Fix(BODY_FORCE_Z); -NODES[2268].Fix(BODY_FORCE_X); -NODES[2268].Fix(BODY_FORCE_Y); -NODES[2268].Fix(BODY_FORCE_Z); -NODES[2269].Fix(BODY_FORCE_X); -NODES[2269].Fix(BODY_FORCE_Y); -NODES[2269].Fix(BODY_FORCE_Z); -NODES[2270].Fix(BODY_FORCE_X); -NODES[2270].Fix(BODY_FORCE_Y); -NODES[2270].Fix(BODY_FORCE_Z); -NODES[2271].Fix(BODY_FORCE_X); -NODES[2271].Fix(BODY_FORCE_Y); -NODES[2271].Fix(BODY_FORCE_Z); -NODES[2273].Fix(BODY_FORCE_X); -NODES[2273].Fix(BODY_FORCE_Y); -NODES[2273].Fix(BODY_FORCE_Z); -NODES[2274].Fix(BODY_FORCE_X); -NODES[2274].Fix(BODY_FORCE_Y); -NODES[2274].Fix(BODY_FORCE_Z); -NODES[2275].Fix(BODY_FORCE_X); -NODES[2275].Fix(BODY_FORCE_Y); -NODES[2275].Fix(BODY_FORCE_Z); -NODES[2276].Fix(BODY_FORCE_X); -NODES[2276].Fix(BODY_FORCE_Y); -NODES[2276].Fix(BODY_FORCE_Z); -NODES[2277].Fix(BODY_FORCE_X); -NODES[2277].Fix(BODY_FORCE_Y); -NODES[2277].Fix(BODY_FORCE_Z); -NODES[2278].Fix(BODY_FORCE_X); -NODES[2278].Fix(BODY_FORCE_Y); -NODES[2278].Fix(BODY_FORCE_Z); -NODES[2279].Fix(BODY_FORCE_X); -NODES[2279].Fix(BODY_FORCE_Y); -NODES[2279].Fix(BODY_FORCE_Z); -NODES[2280].Fix(BODY_FORCE_X); -NODES[2280].Fix(BODY_FORCE_Y); -NODES[2280].Fix(BODY_FORCE_Z); -NODES[2281].Fix(BODY_FORCE_X); -NODES[2281].Fix(BODY_FORCE_Y); -NODES[2281].Fix(BODY_FORCE_Z); -NODES[2282].Fix(BODY_FORCE_X); -NODES[2282].Fix(BODY_FORCE_Y); -NODES[2282].Fix(BODY_FORCE_Z); -NODES[2283].Fix(BODY_FORCE_X); -NODES[2283].Fix(BODY_FORCE_Y); -NODES[2283].Fix(BODY_FORCE_Z); -NODES[2284].Fix(BODY_FORCE_X); -NODES[2284].Fix(BODY_FORCE_Y); -NODES[2284].Fix(BODY_FORCE_Z); -NODES[2285].Fix(BODY_FORCE_X); -NODES[2285].Fix(BODY_FORCE_Y); -NODES[2285].Fix(BODY_FORCE_Z); -NODES[2286].Fix(BODY_FORCE_X); -NODES[2286].Fix(BODY_FORCE_Y); -NODES[2286].Fix(BODY_FORCE_Z); -NODES[2287].Fix(BODY_FORCE_X); -NODES[2287].Fix(BODY_FORCE_Y); -NODES[2287].Fix(BODY_FORCE_Z); -NODES[2288].Fix(BODY_FORCE_X); -NODES[2288].Fix(BODY_FORCE_Y); -NODES[2288].Fix(BODY_FORCE_Z); -NODES[2289].Fix(BODY_FORCE_X); -NODES[2289].Fix(BODY_FORCE_Y); -NODES[2289].Fix(BODY_FORCE_Z); -NODES[2290].Fix(BODY_FORCE_X); -NODES[2290].Fix(BODY_FORCE_Y); -NODES[2290].Fix(BODY_FORCE_Z); -NODES[2291].Fix(BODY_FORCE_X); -NODES[2291].Fix(BODY_FORCE_Y); -NODES[2291].Fix(BODY_FORCE_Z); -NODES[2292].Fix(BODY_FORCE_X); -NODES[2292].Fix(BODY_FORCE_Y); -NODES[2292].Fix(BODY_FORCE_Z); -NODES[2293].Fix(BODY_FORCE_X); -NODES[2293].Fix(BODY_FORCE_Y); -NODES[2293].Fix(BODY_FORCE_Z); -NODES[2294].Fix(BODY_FORCE_X); -NODES[2294].Fix(BODY_FORCE_Y); -NODES[2294].Fix(BODY_FORCE_Z); -NODES[2295].Fix(BODY_FORCE_X); -NODES[2295].Fix(BODY_FORCE_Y); -NODES[2295].Fix(BODY_FORCE_Z); -NODES[2296].Fix(BODY_FORCE_X); -NODES[2296].Fix(BODY_FORCE_Y); -NODES[2296].Fix(BODY_FORCE_Z); -NODES[2297].Fix(BODY_FORCE_X); -NODES[2297].Fix(BODY_FORCE_Y); -NODES[2297].Fix(BODY_FORCE_Z); -NODES[2298].Fix(BODY_FORCE_X); -NODES[2298].Fix(BODY_FORCE_Y); -NODES[2298].Fix(BODY_FORCE_Z); -NODES[2299].Fix(BODY_FORCE_X); -NODES[2299].Fix(BODY_FORCE_Y); -NODES[2299].Fix(BODY_FORCE_Z); -NODES[2300].Fix(BODY_FORCE_X); -NODES[2300].Fix(BODY_FORCE_Y); -NODES[2300].Fix(BODY_FORCE_Z); -NODES[2301].Fix(BODY_FORCE_X); -NODES[2301].Fix(BODY_FORCE_Y); -NODES[2301].Fix(BODY_FORCE_Z); -NODES[2302].Fix(BODY_FORCE_X); -NODES[2302].Fix(BODY_FORCE_Y); -NODES[2302].Fix(BODY_FORCE_Z); -NODES[2304].Fix(BODY_FORCE_X); -NODES[2304].Fix(BODY_FORCE_Y); -NODES[2304].Fix(BODY_FORCE_Z); -NODES[2305].Fix(BODY_FORCE_X); -NODES[2305].Fix(BODY_FORCE_Y); -NODES[2305].Fix(BODY_FORCE_Z); -NODES[2306].Fix(BODY_FORCE_X); -NODES[2306].Fix(BODY_FORCE_Y); -NODES[2306].Fix(BODY_FORCE_Z); -NODES[2307].Fix(BODY_FORCE_X); -NODES[2307].Fix(BODY_FORCE_Y); -NODES[2307].Fix(BODY_FORCE_Z); -NODES[2308].Fix(BODY_FORCE_X); -NODES[2308].Fix(BODY_FORCE_Y); -NODES[2308].Fix(BODY_FORCE_Z); -NODES[2309].Fix(BODY_FORCE_X); -NODES[2309].Fix(BODY_FORCE_Y); -NODES[2309].Fix(BODY_FORCE_Z); -NODES[2310].Fix(BODY_FORCE_X); -NODES[2310].Fix(BODY_FORCE_Y); -NODES[2310].Fix(BODY_FORCE_Z); -NODES[2311].Fix(BODY_FORCE_X); -NODES[2311].Fix(BODY_FORCE_Y); -NODES[2311].Fix(BODY_FORCE_Z); -NODES[2312].Fix(BODY_FORCE_X); -NODES[2312].Fix(BODY_FORCE_Y); -NODES[2312].Fix(BODY_FORCE_Z); -NODES[2313].Fix(BODY_FORCE_X); -NODES[2313].Fix(BODY_FORCE_Y); -NODES[2313].Fix(BODY_FORCE_Z); -NODES[2314].Fix(BODY_FORCE_X); -NODES[2314].Fix(BODY_FORCE_Y); -NODES[2314].Fix(BODY_FORCE_Z); -NODES[2315].Fix(BODY_FORCE_X); -NODES[2315].Fix(BODY_FORCE_Y); -NODES[2315].Fix(BODY_FORCE_Z); -NODES[2316].Fix(BODY_FORCE_X); -NODES[2316].Fix(BODY_FORCE_Y); -NODES[2316].Fix(BODY_FORCE_Z); -NODES[2317].Fix(BODY_FORCE_X); -NODES[2317].Fix(BODY_FORCE_Y); -NODES[2317].Fix(BODY_FORCE_Z); -NODES[2318].Fix(BODY_FORCE_X); -NODES[2318].Fix(BODY_FORCE_Y); -NODES[2318].Fix(BODY_FORCE_Z); -NODES[2319].Fix(BODY_FORCE_X); -NODES[2319].Fix(BODY_FORCE_Y); -NODES[2319].Fix(BODY_FORCE_Z); -NODES[2320].Fix(BODY_FORCE_X); -NODES[2320].Fix(BODY_FORCE_Y); -NODES[2320].Fix(BODY_FORCE_Z); -NODES[2321].Fix(BODY_FORCE_X); -NODES[2321].Fix(BODY_FORCE_Y); -NODES[2321].Fix(BODY_FORCE_Z); -NODES[2322].Fix(BODY_FORCE_X); -NODES[2322].Fix(BODY_FORCE_Y); -NODES[2322].Fix(BODY_FORCE_Z); -NODES[2323].Fix(BODY_FORCE_X); -NODES[2323].Fix(BODY_FORCE_Y); -NODES[2323].Fix(BODY_FORCE_Z); -NODES[2324].Fix(BODY_FORCE_X); -NODES[2324].Fix(BODY_FORCE_Y); -NODES[2324].Fix(BODY_FORCE_Z); -NODES[2325].Fix(BODY_FORCE_X); -NODES[2325].Fix(BODY_FORCE_Y); -NODES[2325].Fix(BODY_FORCE_Z); -NODES[2326].Fix(BODY_FORCE_X); -NODES[2326].Fix(BODY_FORCE_Y); -NODES[2326].Fix(BODY_FORCE_Z); -NODES[2327].Fix(BODY_FORCE_X); -NODES[2327].Fix(BODY_FORCE_Y); -NODES[2327].Fix(BODY_FORCE_Z); -NODES[2328].Fix(BODY_FORCE_X); -NODES[2328].Fix(BODY_FORCE_Y); -NODES[2328].Fix(BODY_FORCE_Z); -NODES[2329].Fix(BODY_FORCE_X); -NODES[2329].Fix(BODY_FORCE_Y); -NODES[2329].Fix(BODY_FORCE_Z); -NODES[2330].Fix(BODY_FORCE_X); -NODES[2330].Fix(BODY_FORCE_Y); -NODES[2330].Fix(BODY_FORCE_Z); -NODES[2331].Fix(BODY_FORCE_X); -NODES[2331].Fix(BODY_FORCE_Y); -NODES[2331].Fix(BODY_FORCE_Z); -NODES[2332].Fix(BODY_FORCE_X); -NODES[2332].Fix(BODY_FORCE_Y); -NODES[2332].Fix(BODY_FORCE_Z); -NODES[2333].Fix(BODY_FORCE_X); -NODES[2333].Fix(BODY_FORCE_Y); -NODES[2333].Fix(BODY_FORCE_Z); -NODES[2334].Fix(BODY_FORCE_X); -NODES[2334].Fix(BODY_FORCE_Y); -NODES[2334].Fix(BODY_FORCE_Z); -NODES[2335].Fix(BODY_FORCE_X); -NODES[2335].Fix(BODY_FORCE_Y); -NODES[2335].Fix(BODY_FORCE_Z); -NODES[2337].Fix(BODY_FORCE_X); -NODES[2337].Fix(BODY_FORCE_Y); -NODES[2337].Fix(BODY_FORCE_Z); -NODES[2338].Fix(BODY_FORCE_X); -NODES[2338].Fix(BODY_FORCE_Y); -NODES[2338].Fix(BODY_FORCE_Z); -NODES[2339].Fix(BODY_FORCE_X); -NODES[2339].Fix(BODY_FORCE_Y); -NODES[2339].Fix(BODY_FORCE_Z); -NODES[2340].Fix(BODY_FORCE_X); -NODES[2340].Fix(BODY_FORCE_Y); -NODES[2340].Fix(BODY_FORCE_Z); -NODES[2341].Fix(BODY_FORCE_X); -NODES[2341].Fix(BODY_FORCE_Y); -NODES[2341].Fix(BODY_FORCE_Z); -NODES[2342].Fix(BODY_FORCE_X); -NODES[2342].Fix(BODY_FORCE_Y); -NODES[2342].Fix(BODY_FORCE_Z); -NODES[2343].Fix(BODY_FORCE_X); -NODES[2343].Fix(BODY_FORCE_Y); -NODES[2343].Fix(BODY_FORCE_Z); -NODES[2344].Fix(BODY_FORCE_X); -NODES[2344].Fix(BODY_FORCE_Y); -NODES[2344].Fix(BODY_FORCE_Z); -NODES[2345].Fix(BODY_FORCE_X); -NODES[2345].Fix(BODY_FORCE_Y); -NODES[2345].Fix(BODY_FORCE_Z); -NODES[2346].Fix(BODY_FORCE_X); -NODES[2346].Fix(BODY_FORCE_Y); -NODES[2346].Fix(BODY_FORCE_Z); -NODES[2347].Fix(BODY_FORCE_X); -NODES[2347].Fix(BODY_FORCE_Y); -NODES[2347].Fix(BODY_FORCE_Z); -NODES[2348].Fix(BODY_FORCE_X); -NODES[2348].Fix(BODY_FORCE_Y); -NODES[2348].Fix(BODY_FORCE_Z); -NODES[2349].Fix(BODY_FORCE_X); -NODES[2349].Fix(BODY_FORCE_Y); -NODES[2349].Fix(BODY_FORCE_Z); -NODES[2350].Fix(BODY_FORCE_X); -NODES[2350].Fix(BODY_FORCE_Y); -NODES[2350].Fix(BODY_FORCE_Z); -NODES[2351].Fix(BODY_FORCE_X); -NODES[2351].Fix(BODY_FORCE_Y); -NODES[2351].Fix(BODY_FORCE_Z); -NODES[2352].Fix(BODY_FORCE_X); -NODES[2352].Fix(BODY_FORCE_Y); -NODES[2352].Fix(BODY_FORCE_Z); -NODES[2353].Fix(BODY_FORCE_X); -NODES[2353].Fix(BODY_FORCE_Y); -NODES[2353].Fix(BODY_FORCE_Z); -NODES[2354].Fix(BODY_FORCE_X); -NODES[2354].Fix(BODY_FORCE_Y); -NODES[2354].Fix(BODY_FORCE_Z); -NODES[2355].Fix(BODY_FORCE_X); -NODES[2355].Fix(BODY_FORCE_Y); -NODES[2355].Fix(BODY_FORCE_Z); -NODES[2356].Fix(BODY_FORCE_X); -NODES[2356].Fix(BODY_FORCE_Y); -NODES[2356].Fix(BODY_FORCE_Z); -NODES[2357].Fix(BODY_FORCE_X); -NODES[2357].Fix(BODY_FORCE_Y); -NODES[2357].Fix(BODY_FORCE_Z); -NODES[2358].Fix(BODY_FORCE_X); -NODES[2358].Fix(BODY_FORCE_Y); -NODES[2358].Fix(BODY_FORCE_Z); -NODES[2359].Fix(BODY_FORCE_X); -NODES[2359].Fix(BODY_FORCE_Y); -NODES[2359].Fix(BODY_FORCE_Z); -NODES[2360].Fix(BODY_FORCE_X); -NODES[2360].Fix(BODY_FORCE_Y); -NODES[2360].Fix(BODY_FORCE_Z); -NODES[2361].Fix(BODY_FORCE_X); -NODES[2361].Fix(BODY_FORCE_Y); -NODES[2361].Fix(BODY_FORCE_Z); -NODES[2362].Fix(BODY_FORCE_X); -NODES[2362].Fix(BODY_FORCE_Y); -NODES[2362].Fix(BODY_FORCE_Z); -NODES[2363].Fix(BODY_FORCE_X); -NODES[2363].Fix(BODY_FORCE_Y); -NODES[2363].Fix(BODY_FORCE_Z); -NODES[2364].Fix(BODY_FORCE_X); -NODES[2364].Fix(BODY_FORCE_Y); -NODES[2364].Fix(BODY_FORCE_Z); -NODES[2365].Fix(BODY_FORCE_X); -NODES[2365].Fix(BODY_FORCE_Y); -NODES[2365].Fix(BODY_FORCE_Z); -NODES[2366].Fix(BODY_FORCE_X); -NODES[2366].Fix(BODY_FORCE_Y); -NODES[2366].Fix(BODY_FORCE_Z); -NODES[2368].Fix(BODY_FORCE_X); -NODES[2368].Fix(BODY_FORCE_Y); -NODES[2368].Fix(BODY_FORCE_Z); -NODES[2369].Fix(BODY_FORCE_X); -NODES[2369].Fix(BODY_FORCE_Y); -NODES[2369].Fix(BODY_FORCE_Z); -NODES[2370].Fix(BODY_FORCE_X); -NODES[2370].Fix(BODY_FORCE_Y); -NODES[2370].Fix(BODY_FORCE_Z); -NODES[2371].Fix(BODY_FORCE_X); -NODES[2371].Fix(BODY_FORCE_Y); -NODES[2371].Fix(BODY_FORCE_Z); -NODES[2372].Fix(BODY_FORCE_X); -NODES[2372].Fix(BODY_FORCE_Y); -NODES[2372].Fix(BODY_FORCE_Z); -NODES[2373].Fix(BODY_FORCE_X); -NODES[2373].Fix(BODY_FORCE_Y); -NODES[2373].Fix(BODY_FORCE_Z); -NODES[2374].Fix(BODY_FORCE_X); -NODES[2374].Fix(BODY_FORCE_Y); -NODES[2374].Fix(BODY_FORCE_Z); -NODES[2375].Fix(BODY_FORCE_X); -NODES[2375].Fix(BODY_FORCE_Y); -NODES[2375].Fix(BODY_FORCE_Z); -NODES[2376].Fix(BODY_FORCE_X); -NODES[2376].Fix(BODY_FORCE_Y); -NODES[2376].Fix(BODY_FORCE_Z); -NODES[2377].Fix(BODY_FORCE_X); -NODES[2377].Fix(BODY_FORCE_Y); -NODES[2377].Fix(BODY_FORCE_Z); -NODES[2378].Fix(BODY_FORCE_X); -NODES[2378].Fix(BODY_FORCE_Y); -NODES[2378].Fix(BODY_FORCE_Z); -NODES[2379].Fix(BODY_FORCE_X); -NODES[2379].Fix(BODY_FORCE_Y); -NODES[2379].Fix(BODY_FORCE_Z); -NODES[2380].Fix(BODY_FORCE_X); -NODES[2380].Fix(BODY_FORCE_Y); -NODES[2380].Fix(BODY_FORCE_Z); -NODES[2381].Fix(BODY_FORCE_X); -NODES[2381].Fix(BODY_FORCE_Y); -NODES[2381].Fix(BODY_FORCE_Z); -NODES[2382].Fix(BODY_FORCE_X); -NODES[2382].Fix(BODY_FORCE_Y); -NODES[2382].Fix(BODY_FORCE_Z); -NODES[2383].Fix(BODY_FORCE_X); -NODES[2383].Fix(BODY_FORCE_Y); -NODES[2383].Fix(BODY_FORCE_Z); -NODES[2384].Fix(BODY_FORCE_X); -NODES[2384].Fix(BODY_FORCE_Y); -NODES[2384].Fix(BODY_FORCE_Z); -NODES[2385].Fix(BODY_FORCE_X); -NODES[2385].Fix(BODY_FORCE_Y); -NODES[2385].Fix(BODY_FORCE_Z); -NODES[2386].Fix(BODY_FORCE_X); -NODES[2386].Fix(BODY_FORCE_Y); -NODES[2386].Fix(BODY_FORCE_Z); -NODES[2387].Fix(BODY_FORCE_X); -NODES[2387].Fix(BODY_FORCE_Y); -NODES[2387].Fix(BODY_FORCE_Z); -NODES[2388].Fix(BODY_FORCE_X); -NODES[2388].Fix(BODY_FORCE_Y); -NODES[2388].Fix(BODY_FORCE_Z); -NODES[2389].Fix(BODY_FORCE_X); -NODES[2389].Fix(BODY_FORCE_Y); -NODES[2389].Fix(BODY_FORCE_Z); -NODES[2390].Fix(BODY_FORCE_X); -NODES[2390].Fix(BODY_FORCE_Y); -NODES[2390].Fix(BODY_FORCE_Z); -NODES[2391].Fix(BODY_FORCE_X); -NODES[2391].Fix(BODY_FORCE_Y); -NODES[2391].Fix(BODY_FORCE_Z); -NODES[2392].Fix(BODY_FORCE_X); -NODES[2392].Fix(BODY_FORCE_Y); -NODES[2392].Fix(BODY_FORCE_Z); -NODES[2393].Fix(BODY_FORCE_X); -NODES[2393].Fix(BODY_FORCE_Y); -NODES[2393].Fix(BODY_FORCE_Z); -NODES[2394].Fix(BODY_FORCE_X); -NODES[2394].Fix(BODY_FORCE_Y); -NODES[2394].Fix(BODY_FORCE_Z); -NODES[2395].Fix(BODY_FORCE_X); -NODES[2395].Fix(BODY_FORCE_Y); -NODES[2395].Fix(BODY_FORCE_Z); -NODES[2396].Fix(BODY_FORCE_X); -NODES[2396].Fix(BODY_FORCE_Y); -NODES[2396].Fix(BODY_FORCE_Z); -NODES[2398].Fix(BODY_FORCE_X); -NODES[2398].Fix(BODY_FORCE_Y); -NODES[2398].Fix(BODY_FORCE_Z); -NODES[2399].Fix(BODY_FORCE_X); -NODES[2399].Fix(BODY_FORCE_Y); -NODES[2399].Fix(BODY_FORCE_Z); -NODES[2400].Fix(BODY_FORCE_X); -NODES[2400].Fix(BODY_FORCE_Y); -NODES[2400].Fix(BODY_FORCE_Z); -NODES[2401].Fix(BODY_FORCE_X); -NODES[2401].Fix(BODY_FORCE_Y); -NODES[2401].Fix(BODY_FORCE_Z); -NODES[2402].Fix(BODY_FORCE_X); -NODES[2402].Fix(BODY_FORCE_Y); -NODES[2402].Fix(BODY_FORCE_Z); -NODES[2403].Fix(BODY_FORCE_X); -NODES[2403].Fix(BODY_FORCE_Y); -NODES[2403].Fix(BODY_FORCE_Z); -NODES[2404].Fix(BODY_FORCE_X); -NODES[2404].Fix(BODY_FORCE_Y); -NODES[2404].Fix(BODY_FORCE_Z); -NODES[2405].Fix(BODY_FORCE_X); -NODES[2405].Fix(BODY_FORCE_Y); -NODES[2405].Fix(BODY_FORCE_Z); -NODES[2406].Fix(BODY_FORCE_X); -NODES[2406].Fix(BODY_FORCE_Y); -NODES[2406].Fix(BODY_FORCE_Z); -NODES[2407].Fix(BODY_FORCE_X); -NODES[2407].Fix(BODY_FORCE_Y); -NODES[2407].Fix(BODY_FORCE_Z); -NODES[2408].Fix(BODY_FORCE_X); -NODES[2408].Fix(BODY_FORCE_Y); -NODES[2408].Fix(BODY_FORCE_Z); -NODES[2409].Fix(BODY_FORCE_X); -NODES[2409].Fix(BODY_FORCE_Y); -NODES[2409].Fix(BODY_FORCE_Z); -NODES[2410].Fix(BODY_FORCE_X); -NODES[2410].Fix(BODY_FORCE_Y); -NODES[2410].Fix(BODY_FORCE_Z); -NODES[2411].Fix(BODY_FORCE_X); -NODES[2411].Fix(BODY_FORCE_Y); -NODES[2411].Fix(BODY_FORCE_Z); -NODES[2412].Fix(BODY_FORCE_X); -NODES[2412].Fix(BODY_FORCE_Y); -NODES[2412].Fix(BODY_FORCE_Z); -NODES[2413].Fix(BODY_FORCE_X); -NODES[2413].Fix(BODY_FORCE_Y); -NODES[2413].Fix(BODY_FORCE_Z); -NODES[2414].Fix(BODY_FORCE_X); -NODES[2414].Fix(BODY_FORCE_Y); -NODES[2414].Fix(BODY_FORCE_Z); -NODES[2415].Fix(BODY_FORCE_X); -NODES[2415].Fix(BODY_FORCE_Y); -NODES[2415].Fix(BODY_FORCE_Z); -NODES[2416].Fix(BODY_FORCE_X); -NODES[2416].Fix(BODY_FORCE_Y); -NODES[2416].Fix(BODY_FORCE_Z); -NODES[2417].Fix(BODY_FORCE_X); -NODES[2417].Fix(BODY_FORCE_Y); -NODES[2417].Fix(BODY_FORCE_Z); -NODES[2418].Fix(BODY_FORCE_X); -NODES[2418].Fix(BODY_FORCE_Y); -NODES[2418].Fix(BODY_FORCE_Z); -NODES[2419].Fix(BODY_FORCE_X); -NODES[2419].Fix(BODY_FORCE_Y); -NODES[2419].Fix(BODY_FORCE_Z); -NODES[2420].Fix(BODY_FORCE_X); -NODES[2420].Fix(BODY_FORCE_Y); -NODES[2420].Fix(BODY_FORCE_Z); -NODES[2421].Fix(BODY_FORCE_X); -NODES[2421].Fix(BODY_FORCE_Y); -NODES[2421].Fix(BODY_FORCE_Z); -NODES[2422].Fix(BODY_FORCE_X); -NODES[2422].Fix(BODY_FORCE_Y); -NODES[2422].Fix(BODY_FORCE_Z); -NODES[2423].Fix(BODY_FORCE_X); -NODES[2423].Fix(BODY_FORCE_Y); -NODES[2423].Fix(BODY_FORCE_Z); -NODES[2424].Fix(BODY_FORCE_X); -NODES[2424].Fix(BODY_FORCE_Y); -NODES[2424].Fix(BODY_FORCE_Z); -NODES[2425].Fix(BODY_FORCE_X); -NODES[2425].Fix(BODY_FORCE_Y); -NODES[2425].Fix(BODY_FORCE_Z); -NODES[2426].Fix(BODY_FORCE_X); -NODES[2426].Fix(BODY_FORCE_Y); -NODES[2426].Fix(BODY_FORCE_Z); -NODES[2427].Fix(BODY_FORCE_X); -NODES[2427].Fix(BODY_FORCE_Y); -NODES[2427].Fix(BODY_FORCE_Z); -NODES[2429].Fix(BODY_FORCE_X); -NODES[2429].Fix(BODY_FORCE_Y); -NODES[2429].Fix(BODY_FORCE_Z); -NODES[2430].Fix(BODY_FORCE_X); -NODES[2430].Fix(BODY_FORCE_Y); -NODES[2430].Fix(BODY_FORCE_Z); -NODES[2431].Fix(BODY_FORCE_X); -NODES[2431].Fix(BODY_FORCE_Y); -NODES[2431].Fix(BODY_FORCE_Z); -NODES[2432].Fix(BODY_FORCE_X); -NODES[2432].Fix(BODY_FORCE_Y); -NODES[2432].Fix(BODY_FORCE_Z); -NODES[2433].Fix(BODY_FORCE_X); -NODES[2433].Fix(BODY_FORCE_Y); -NODES[2433].Fix(BODY_FORCE_Z); -NODES[2434].Fix(BODY_FORCE_X); -NODES[2434].Fix(BODY_FORCE_Y); -NODES[2434].Fix(BODY_FORCE_Z); -NODES[2435].Fix(BODY_FORCE_X); -NODES[2435].Fix(BODY_FORCE_Y); -NODES[2435].Fix(BODY_FORCE_Z); -NODES[2436].Fix(BODY_FORCE_X); -NODES[2436].Fix(BODY_FORCE_Y); -NODES[2436].Fix(BODY_FORCE_Z); -NODES[2437].Fix(BODY_FORCE_X); -NODES[2437].Fix(BODY_FORCE_Y); -NODES[2437].Fix(BODY_FORCE_Z); -NODES[2438].Fix(BODY_FORCE_X); -NODES[2438].Fix(BODY_FORCE_Y); -NODES[2438].Fix(BODY_FORCE_Z); -NODES[2439].Fix(BODY_FORCE_X); -NODES[2439].Fix(BODY_FORCE_Y); -NODES[2439].Fix(BODY_FORCE_Z); -NODES[2440].Fix(BODY_FORCE_X); -NODES[2440].Fix(BODY_FORCE_Y); -NODES[2440].Fix(BODY_FORCE_Z); -NODES[2441].Fix(BODY_FORCE_X); -NODES[2441].Fix(BODY_FORCE_Y); -NODES[2441].Fix(BODY_FORCE_Z); -NODES[2442].Fix(BODY_FORCE_X); -NODES[2442].Fix(BODY_FORCE_Y); -NODES[2442].Fix(BODY_FORCE_Z); -NODES[2443].Fix(BODY_FORCE_X); -NODES[2443].Fix(BODY_FORCE_Y); -NODES[2443].Fix(BODY_FORCE_Z); -NODES[2444].Fix(BODY_FORCE_X); -NODES[2444].Fix(BODY_FORCE_Y); -NODES[2444].Fix(BODY_FORCE_Z); -NODES[2445].Fix(BODY_FORCE_X); -NODES[2445].Fix(BODY_FORCE_Y); -NODES[2445].Fix(BODY_FORCE_Z); -NODES[2446].Fix(BODY_FORCE_X); -NODES[2446].Fix(BODY_FORCE_Y); -NODES[2446].Fix(BODY_FORCE_Z); -NODES[2447].Fix(BODY_FORCE_X); -NODES[2447].Fix(BODY_FORCE_Y); -NODES[2447].Fix(BODY_FORCE_Z); -NODES[2448].Fix(BODY_FORCE_X); -NODES[2448].Fix(BODY_FORCE_Y); -NODES[2448].Fix(BODY_FORCE_Z); -NODES[2449].Fix(BODY_FORCE_X); -NODES[2449].Fix(BODY_FORCE_Y); -NODES[2449].Fix(BODY_FORCE_Z); -NODES[2450].Fix(BODY_FORCE_X); -NODES[2450].Fix(BODY_FORCE_Y); -NODES[2450].Fix(BODY_FORCE_Z); -NODES[2451].Fix(BODY_FORCE_X); -NODES[2451].Fix(BODY_FORCE_Y); -NODES[2451].Fix(BODY_FORCE_Z); -NODES[2452].Fix(BODY_FORCE_X); -NODES[2452].Fix(BODY_FORCE_Y); -NODES[2452].Fix(BODY_FORCE_Z); -NODES[2453].Fix(BODY_FORCE_X); -NODES[2453].Fix(BODY_FORCE_Y); -NODES[2453].Fix(BODY_FORCE_Z); -NODES[2454].Fix(BODY_FORCE_X); -NODES[2454].Fix(BODY_FORCE_Y); -NODES[2454].Fix(BODY_FORCE_Z); -NODES[2455].Fix(BODY_FORCE_X); -NODES[2455].Fix(BODY_FORCE_Y); -NODES[2455].Fix(BODY_FORCE_Z); -NODES[2456].Fix(BODY_FORCE_X); -NODES[2456].Fix(BODY_FORCE_Y); -NODES[2456].Fix(BODY_FORCE_Z); -NODES[2457].Fix(BODY_FORCE_X); -NODES[2457].Fix(BODY_FORCE_Y); -NODES[2457].Fix(BODY_FORCE_Z); -NODES[2458].Fix(BODY_FORCE_X); -NODES[2458].Fix(BODY_FORCE_Y); -NODES[2458].Fix(BODY_FORCE_Z); -NODES[2459].Fix(BODY_FORCE_X); -NODES[2459].Fix(BODY_FORCE_Y); -NODES[2459].Fix(BODY_FORCE_Z); -NODES[2460].Fix(BODY_FORCE_X); -NODES[2460].Fix(BODY_FORCE_Y); -NODES[2460].Fix(BODY_FORCE_Z); -NODES[2461].Fix(BODY_FORCE_X); -NODES[2461].Fix(BODY_FORCE_Y); -NODES[2461].Fix(BODY_FORCE_Z); -NODES[2463].Fix(BODY_FORCE_X); -NODES[2463].Fix(BODY_FORCE_Y); -NODES[2463].Fix(BODY_FORCE_Z); -NODES[2464].Fix(BODY_FORCE_X); -NODES[2464].Fix(BODY_FORCE_Y); -NODES[2464].Fix(BODY_FORCE_Z); -NODES[2465].Fix(BODY_FORCE_X); -NODES[2465].Fix(BODY_FORCE_Y); -NODES[2465].Fix(BODY_FORCE_Z); -NODES[2466].Fix(BODY_FORCE_X); -NODES[2466].Fix(BODY_FORCE_Y); -NODES[2466].Fix(BODY_FORCE_Z); -NODES[2467].Fix(BODY_FORCE_X); -NODES[2467].Fix(BODY_FORCE_Y); -NODES[2467].Fix(BODY_FORCE_Z); -NODES[2468].Fix(BODY_FORCE_X); -NODES[2468].Fix(BODY_FORCE_Y); -NODES[2468].Fix(BODY_FORCE_Z); -NODES[2469].Fix(BODY_FORCE_X); -NODES[2469].Fix(BODY_FORCE_Y); -NODES[2469].Fix(BODY_FORCE_Z); -NODES[2470].Fix(BODY_FORCE_X); -NODES[2470].Fix(BODY_FORCE_Y); -NODES[2470].Fix(BODY_FORCE_Z); -NODES[2471].Fix(BODY_FORCE_X); -NODES[2471].Fix(BODY_FORCE_Y); -NODES[2471].Fix(BODY_FORCE_Z); -NODES[2472].Fix(BODY_FORCE_X); -NODES[2472].Fix(BODY_FORCE_Y); -NODES[2472].Fix(BODY_FORCE_Z); -NODES[2473].Fix(BODY_FORCE_X); -NODES[2473].Fix(BODY_FORCE_Y); -NODES[2473].Fix(BODY_FORCE_Z); -NODES[2474].Fix(BODY_FORCE_X); -NODES[2474].Fix(BODY_FORCE_Y); -NODES[2474].Fix(BODY_FORCE_Z); -NODES[2475].Fix(BODY_FORCE_X); -NODES[2475].Fix(BODY_FORCE_Y); -NODES[2475].Fix(BODY_FORCE_Z); -NODES[2476].Fix(BODY_FORCE_X); -NODES[2476].Fix(BODY_FORCE_Y); -NODES[2476].Fix(BODY_FORCE_Z); -NODES[2477].Fix(BODY_FORCE_X); -NODES[2477].Fix(BODY_FORCE_Y); -NODES[2477].Fix(BODY_FORCE_Z); -NODES[2478].Fix(BODY_FORCE_X); -NODES[2478].Fix(BODY_FORCE_Y); -NODES[2478].Fix(BODY_FORCE_Z); -NODES[2479].Fix(BODY_FORCE_X); -NODES[2479].Fix(BODY_FORCE_Y); -NODES[2479].Fix(BODY_FORCE_Z); -NODES[2480].Fix(BODY_FORCE_X); -NODES[2480].Fix(BODY_FORCE_Y); -NODES[2480].Fix(BODY_FORCE_Z); -NODES[2481].Fix(BODY_FORCE_X); -NODES[2481].Fix(BODY_FORCE_Y); -NODES[2481].Fix(BODY_FORCE_Z); -NODES[2482].Fix(BODY_FORCE_X); -NODES[2482].Fix(BODY_FORCE_Y); -NODES[2482].Fix(BODY_FORCE_Z); -NODES[2483].Fix(BODY_FORCE_X); -NODES[2483].Fix(BODY_FORCE_Y); -NODES[2483].Fix(BODY_FORCE_Z); -NODES[2484].Fix(BODY_FORCE_X); -NODES[2484].Fix(BODY_FORCE_Y); -NODES[2484].Fix(BODY_FORCE_Z); -NODES[2485].Fix(BODY_FORCE_X); -NODES[2485].Fix(BODY_FORCE_Y); -NODES[2485].Fix(BODY_FORCE_Z); -NODES[2486].Fix(BODY_FORCE_X); -NODES[2486].Fix(BODY_FORCE_Y); -NODES[2486].Fix(BODY_FORCE_Z); -NODES[2487].Fix(BODY_FORCE_X); -NODES[2487].Fix(BODY_FORCE_Y); -NODES[2487].Fix(BODY_FORCE_Z); -NODES[2488].Fix(BODY_FORCE_X); -NODES[2488].Fix(BODY_FORCE_Y); -NODES[2488].Fix(BODY_FORCE_Z); -NODES[2489].Fix(BODY_FORCE_X); -NODES[2489].Fix(BODY_FORCE_Y); -NODES[2489].Fix(BODY_FORCE_Z); -NODES[2490].Fix(BODY_FORCE_X); -NODES[2490].Fix(BODY_FORCE_Y); -NODES[2490].Fix(BODY_FORCE_Z); -NODES[2491].Fix(BODY_FORCE_X); -NODES[2491].Fix(BODY_FORCE_Y); -NODES[2491].Fix(BODY_FORCE_Z); -NODES[2493].Fix(BODY_FORCE_X); -NODES[2493].Fix(BODY_FORCE_Y); -NODES[2493].Fix(BODY_FORCE_Z); -NODES[2494].Fix(BODY_FORCE_X); -NODES[2494].Fix(BODY_FORCE_Y); -NODES[2494].Fix(BODY_FORCE_Z); -NODES[2495].Fix(BODY_FORCE_X); -NODES[2495].Fix(BODY_FORCE_Y); -NODES[2495].Fix(BODY_FORCE_Z); -NODES[2496].Fix(BODY_FORCE_X); -NODES[2496].Fix(BODY_FORCE_Y); -NODES[2496].Fix(BODY_FORCE_Z); -NODES[2497].Fix(BODY_FORCE_X); -NODES[2497].Fix(BODY_FORCE_Y); -NODES[2497].Fix(BODY_FORCE_Z); -NODES[2498].Fix(BODY_FORCE_X); -NODES[2498].Fix(BODY_FORCE_Y); -NODES[2498].Fix(BODY_FORCE_Z); -NODES[2499].Fix(BODY_FORCE_X); -NODES[2499].Fix(BODY_FORCE_Y); -NODES[2499].Fix(BODY_FORCE_Z); -NODES[2500].Fix(BODY_FORCE_X); -NODES[2500].Fix(BODY_FORCE_Y); -NODES[2500].Fix(BODY_FORCE_Z); -NODES[2501].Fix(BODY_FORCE_X); -NODES[2501].Fix(BODY_FORCE_Y); -NODES[2501].Fix(BODY_FORCE_Z); -NODES[2502].Fix(BODY_FORCE_X); -NODES[2502].Fix(BODY_FORCE_Y); -NODES[2502].Fix(BODY_FORCE_Z); -NODES[2503].Fix(BODY_FORCE_X); -NODES[2503].Fix(BODY_FORCE_Y); -NODES[2503].Fix(BODY_FORCE_Z); -NODES[2504].Fix(BODY_FORCE_X); -NODES[2504].Fix(BODY_FORCE_Y); -NODES[2504].Fix(BODY_FORCE_Z); -NODES[2505].Fix(BODY_FORCE_X); -NODES[2505].Fix(BODY_FORCE_Y); -NODES[2505].Fix(BODY_FORCE_Z); -NODES[2506].Fix(BODY_FORCE_X); -NODES[2506].Fix(BODY_FORCE_Y); -NODES[2506].Fix(BODY_FORCE_Z); -NODES[2507].Fix(BODY_FORCE_X); -NODES[2507].Fix(BODY_FORCE_Y); -NODES[2507].Fix(BODY_FORCE_Z); -NODES[2508].Fix(BODY_FORCE_X); -NODES[2508].Fix(BODY_FORCE_Y); -NODES[2508].Fix(BODY_FORCE_Z); -NODES[2509].Fix(BODY_FORCE_X); -NODES[2509].Fix(BODY_FORCE_Y); -NODES[2509].Fix(BODY_FORCE_Z); -NODES[2510].Fix(BODY_FORCE_X); -NODES[2510].Fix(BODY_FORCE_Y); -NODES[2510].Fix(BODY_FORCE_Z); -NODES[2511].Fix(BODY_FORCE_X); -NODES[2511].Fix(BODY_FORCE_Y); -NODES[2511].Fix(BODY_FORCE_Z); -NODES[2512].Fix(BODY_FORCE_X); -NODES[2512].Fix(BODY_FORCE_Y); -NODES[2512].Fix(BODY_FORCE_Z); -NODES[2513].Fix(BODY_FORCE_X); -NODES[2513].Fix(BODY_FORCE_Y); -NODES[2513].Fix(BODY_FORCE_Z); -NODES[2514].Fix(BODY_FORCE_X); -NODES[2514].Fix(BODY_FORCE_Y); -NODES[2514].Fix(BODY_FORCE_Z); -NODES[2515].Fix(BODY_FORCE_X); -NODES[2515].Fix(BODY_FORCE_Y); -NODES[2515].Fix(BODY_FORCE_Z); -NODES[2516].Fix(BODY_FORCE_X); -NODES[2516].Fix(BODY_FORCE_Y); -NODES[2516].Fix(BODY_FORCE_Z); -NODES[2517].Fix(BODY_FORCE_X); -NODES[2517].Fix(BODY_FORCE_Y); -NODES[2517].Fix(BODY_FORCE_Z); -NODES[2518].Fix(BODY_FORCE_X); -NODES[2518].Fix(BODY_FORCE_Y); -NODES[2518].Fix(BODY_FORCE_Z); -NODES[2519].Fix(BODY_FORCE_X); -NODES[2519].Fix(BODY_FORCE_Y); -NODES[2519].Fix(BODY_FORCE_Z); -NODES[2520].Fix(BODY_FORCE_X); -NODES[2520].Fix(BODY_FORCE_Y); -NODES[2520].Fix(BODY_FORCE_Z); -NODES[2521].Fix(BODY_FORCE_X); -NODES[2521].Fix(BODY_FORCE_Y); -NODES[2521].Fix(BODY_FORCE_Z); -NODES[2523].Fix(BODY_FORCE_X); -NODES[2523].Fix(BODY_FORCE_Y); -NODES[2523].Fix(BODY_FORCE_Z); -NODES[2524].Fix(BODY_FORCE_X); -NODES[2524].Fix(BODY_FORCE_Y); -NODES[2524].Fix(BODY_FORCE_Z); -NODES[2525].Fix(BODY_FORCE_X); -NODES[2525].Fix(BODY_FORCE_Y); -NODES[2525].Fix(BODY_FORCE_Z); -NODES[2526].Fix(BODY_FORCE_X); -NODES[2526].Fix(BODY_FORCE_Y); -NODES[2526].Fix(BODY_FORCE_Z); -NODES[2527].Fix(BODY_FORCE_X); -NODES[2527].Fix(BODY_FORCE_Y); -NODES[2527].Fix(BODY_FORCE_Z); -NODES[2528].Fix(BODY_FORCE_X); -NODES[2528].Fix(BODY_FORCE_Y); -NODES[2528].Fix(BODY_FORCE_Z); -NODES[2529].Fix(BODY_FORCE_X); -NODES[2529].Fix(BODY_FORCE_Y); -NODES[2529].Fix(BODY_FORCE_Z); -NODES[2530].Fix(BODY_FORCE_X); -NODES[2530].Fix(BODY_FORCE_Y); -NODES[2530].Fix(BODY_FORCE_Z); -NODES[2531].Fix(BODY_FORCE_X); -NODES[2531].Fix(BODY_FORCE_Y); -NODES[2531].Fix(BODY_FORCE_Z); -NODES[2532].Fix(BODY_FORCE_X); -NODES[2532].Fix(BODY_FORCE_Y); -NODES[2532].Fix(BODY_FORCE_Z); -NODES[2533].Fix(BODY_FORCE_X); -NODES[2533].Fix(BODY_FORCE_Y); -NODES[2533].Fix(BODY_FORCE_Z); -NODES[2534].Fix(BODY_FORCE_X); -NODES[2534].Fix(BODY_FORCE_Y); -NODES[2534].Fix(BODY_FORCE_Z); -NODES[2535].Fix(BODY_FORCE_X); -NODES[2535].Fix(BODY_FORCE_Y); -NODES[2535].Fix(BODY_FORCE_Z); -NODES[2536].Fix(BODY_FORCE_X); -NODES[2536].Fix(BODY_FORCE_Y); -NODES[2536].Fix(BODY_FORCE_Z); -NODES[2537].Fix(BODY_FORCE_X); -NODES[2537].Fix(BODY_FORCE_Y); -NODES[2537].Fix(BODY_FORCE_Z); -NODES[2538].Fix(BODY_FORCE_X); -NODES[2538].Fix(BODY_FORCE_Y); -NODES[2538].Fix(BODY_FORCE_Z); -NODES[2539].Fix(BODY_FORCE_X); -NODES[2539].Fix(BODY_FORCE_Y); -NODES[2539].Fix(BODY_FORCE_Z); -NODES[2540].Fix(BODY_FORCE_X); -NODES[2540].Fix(BODY_FORCE_Y); -NODES[2540].Fix(BODY_FORCE_Z); -NODES[2541].Fix(BODY_FORCE_X); -NODES[2541].Fix(BODY_FORCE_Y); -NODES[2541].Fix(BODY_FORCE_Z); -NODES[2542].Fix(BODY_FORCE_X); -NODES[2542].Fix(BODY_FORCE_Y); -NODES[2542].Fix(BODY_FORCE_Z); -NODES[2543].Fix(BODY_FORCE_X); -NODES[2543].Fix(BODY_FORCE_Y); -NODES[2543].Fix(BODY_FORCE_Z); -NODES[2544].Fix(BODY_FORCE_X); -NODES[2544].Fix(BODY_FORCE_Y); -NODES[2544].Fix(BODY_FORCE_Z); -NODES[2545].Fix(BODY_FORCE_X); -NODES[2545].Fix(BODY_FORCE_Y); -NODES[2545].Fix(BODY_FORCE_Z); -NODES[2546].Fix(BODY_FORCE_X); -NODES[2546].Fix(BODY_FORCE_Y); -NODES[2546].Fix(BODY_FORCE_Z); -NODES[2547].Fix(BODY_FORCE_X); -NODES[2547].Fix(BODY_FORCE_Y); -NODES[2547].Fix(BODY_FORCE_Z); -NODES[2548].Fix(BODY_FORCE_X); -NODES[2548].Fix(BODY_FORCE_Y); -NODES[2548].Fix(BODY_FORCE_Z); -NODES[2549].Fix(BODY_FORCE_X); -NODES[2549].Fix(BODY_FORCE_Y); -NODES[2549].Fix(BODY_FORCE_Z); -NODES[2550].Fix(BODY_FORCE_X); -NODES[2550].Fix(BODY_FORCE_Y); -NODES[2550].Fix(BODY_FORCE_Z); -NODES[2552].Fix(BODY_FORCE_X); -NODES[2552].Fix(BODY_FORCE_Y); -NODES[2552].Fix(BODY_FORCE_Z); -NODES[2553].Fix(BODY_FORCE_X); -NODES[2553].Fix(BODY_FORCE_Y); -NODES[2553].Fix(BODY_FORCE_Z); -NODES[2554].Fix(BODY_FORCE_X); -NODES[2554].Fix(BODY_FORCE_Y); -NODES[2554].Fix(BODY_FORCE_Z); -NODES[2555].Fix(BODY_FORCE_X); -NODES[2555].Fix(BODY_FORCE_Y); -NODES[2555].Fix(BODY_FORCE_Z); -NODES[2556].Fix(BODY_FORCE_X); -NODES[2556].Fix(BODY_FORCE_Y); -NODES[2556].Fix(BODY_FORCE_Z); -NODES[2557].Fix(BODY_FORCE_X); -NODES[2557].Fix(BODY_FORCE_Y); -NODES[2557].Fix(BODY_FORCE_Z); -NODES[2558].Fix(BODY_FORCE_X); -NODES[2558].Fix(BODY_FORCE_Y); -NODES[2558].Fix(BODY_FORCE_Z); -NODES[2559].Fix(BODY_FORCE_X); -NODES[2559].Fix(BODY_FORCE_Y); -NODES[2559].Fix(BODY_FORCE_Z); -NODES[2560].Fix(BODY_FORCE_X); -NODES[2560].Fix(BODY_FORCE_Y); -NODES[2560].Fix(BODY_FORCE_Z); -NODES[2561].Fix(BODY_FORCE_X); -NODES[2561].Fix(BODY_FORCE_Y); -NODES[2561].Fix(BODY_FORCE_Z); -NODES[2562].Fix(BODY_FORCE_X); -NODES[2562].Fix(BODY_FORCE_Y); -NODES[2562].Fix(BODY_FORCE_Z); -NODES[2563].Fix(BODY_FORCE_X); -NODES[2563].Fix(BODY_FORCE_Y); -NODES[2563].Fix(BODY_FORCE_Z); -NODES[2564].Fix(BODY_FORCE_X); -NODES[2564].Fix(BODY_FORCE_Y); -NODES[2564].Fix(BODY_FORCE_Z); -NODES[2565].Fix(BODY_FORCE_X); -NODES[2565].Fix(BODY_FORCE_Y); -NODES[2565].Fix(BODY_FORCE_Z); -NODES[2566].Fix(BODY_FORCE_X); -NODES[2566].Fix(BODY_FORCE_Y); -NODES[2566].Fix(BODY_FORCE_Z); -NODES[2567].Fix(BODY_FORCE_X); -NODES[2567].Fix(BODY_FORCE_Y); -NODES[2567].Fix(BODY_FORCE_Z); -NODES[2568].Fix(BODY_FORCE_X); -NODES[2568].Fix(BODY_FORCE_Y); -NODES[2568].Fix(BODY_FORCE_Z); -NODES[2569].Fix(BODY_FORCE_X); -NODES[2569].Fix(BODY_FORCE_Y); -NODES[2569].Fix(BODY_FORCE_Z); -NODES[2570].Fix(BODY_FORCE_X); -NODES[2570].Fix(BODY_FORCE_Y); -NODES[2570].Fix(BODY_FORCE_Z); -NODES[2571].Fix(BODY_FORCE_X); -NODES[2571].Fix(BODY_FORCE_Y); -NODES[2571].Fix(BODY_FORCE_Z); -NODES[2572].Fix(BODY_FORCE_X); -NODES[2572].Fix(BODY_FORCE_Y); -NODES[2572].Fix(BODY_FORCE_Z); -NODES[2573].Fix(BODY_FORCE_X); -NODES[2573].Fix(BODY_FORCE_Y); -NODES[2573].Fix(BODY_FORCE_Z); -NODES[2574].Fix(BODY_FORCE_X); -NODES[2574].Fix(BODY_FORCE_Y); -NODES[2574].Fix(BODY_FORCE_Z); -NODES[2575].Fix(BODY_FORCE_X); -NODES[2575].Fix(BODY_FORCE_Y); -NODES[2575].Fix(BODY_FORCE_Z); -NODES[2576].Fix(BODY_FORCE_X); -NODES[2576].Fix(BODY_FORCE_Y); -NODES[2576].Fix(BODY_FORCE_Z); -NODES[2577].Fix(BODY_FORCE_X); -NODES[2577].Fix(BODY_FORCE_Y); -NODES[2577].Fix(BODY_FORCE_Z); -NODES[2578].Fix(BODY_FORCE_X); -NODES[2578].Fix(BODY_FORCE_Y); -NODES[2578].Fix(BODY_FORCE_Z); -NODES[2579].Fix(BODY_FORCE_X); -NODES[2579].Fix(BODY_FORCE_Y); -NODES[2579].Fix(BODY_FORCE_Z); -NODES[2580].Fix(BODY_FORCE_X); -NODES[2580].Fix(BODY_FORCE_Y); -NODES[2580].Fix(BODY_FORCE_Z); -NODES[2581].Fix(BODY_FORCE_X); -NODES[2581].Fix(BODY_FORCE_Y); -NODES[2581].Fix(BODY_FORCE_Z); -NODES[2583].Fix(BODY_FORCE_X); -NODES[2583].Fix(BODY_FORCE_Y); -NODES[2583].Fix(BODY_FORCE_Z); -NODES[2584].Fix(BODY_FORCE_X); -NODES[2584].Fix(BODY_FORCE_Y); -NODES[2584].Fix(BODY_FORCE_Z); -NODES[2585].Fix(BODY_FORCE_X); -NODES[2585].Fix(BODY_FORCE_Y); -NODES[2585].Fix(BODY_FORCE_Z); -NODES[2586].Fix(BODY_FORCE_X); -NODES[2586].Fix(BODY_FORCE_Y); -NODES[2586].Fix(BODY_FORCE_Z); -NODES[2587].Fix(BODY_FORCE_X); -NODES[2587].Fix(BODY_FORCE_Y); -NODES[2587].Fix(BODY_FORCE_Z); -NODES[2588].Fix(BODY_FORCE_X); -NODES[2588].Fix(BODY_FORCE_Y); -NODES[2588].Fix(BODY_FORCE_Z); -NODES[2589].Fix(BODY_FORCE_X); -NODES[2589].Fix(BODY_FORCE_Y); -NODES[2589].Fix(BODY_FORCE_Z); -NODES[2590].Fix(BODY_FORCE_X); -NODES[2590].Fix(BODY_FORCE_Y); -NODES[2590].Fix(BODY_FORCE_Z); -NODES[2591].Fix(BODY_FORCE_X); -NODES[2591].Fix(BODY_FORCE_Y); -NODES[2591].Fix(BODY_FORCE_Z); -NODES[2592].Fix(BODY_FORCE_X); -NODES[2592].Fix(BODY_FORCE_Y); -NODES[2592].Fix(BODY_FORCE_Z); -NODES[2593].Fix(BODY_FORCE_X); -NODES[2593].Fix(BODY_FORCE_Y); -NODES[2593].Fix(BODY_FORCE_Z); -NODES[2594].Fix(BODY_FORCE_X); -NODES[2594].Fix(BODY_FORCE_Y); -NODES[2594].Fix(BODY_FORCE_Z); -NODES[2595].Fix(BODY_FORCE_X); -NODES[2595].Fix(BODY_FORCE_Y); -NODES[2595].Fix(BODY_FORCE_Z); -NODES[2596].Fix(BODY_FORCE_X); -NODES[2596].Fix(BODY_FORCE_Y); -NODES[2596].Fix(BODY_FORCE_Z); -NODES[2597].Fix(BODY_FORCE_X); -NODES[2597].Fix(BODY_FORCE_Y); -NODES[2597].Fix(BODY_FORCE_Z); -NODES[2598].Fix(BODY_FORCE_X); -NODES[2598].Fix(BODY_FORCE_Y); -NODES[2598].Fix(BODY_FORCE_Z); -NODES[2599].Fix(BODY_FORCE_X); -NODES[2599].Fix(BODY_FORCE_Y); -NODES[2599].Fix(BODY_FORCE_Z); -NODES[2600].Fix(BODY_FORCE_X); -NODES[2600].Fix(BODY_FORCE_Y); -NODES[2600].Fix(BODY_FORCE_Z); -NODES[2601].Fix(BODY_FORCE_X); -NODES[2601].Fix(BODY_FORCE_Y); -NODES[2601].Fix(BODY_FORCE_Z); -NODES[2602].Fix(BODY_FORCE_X); -NODES[2602].Fix(BODY_FORCE_Y); -NODES[2602].Fix(BODY_FORCE_Z); -NODES[2603].Fix(BODY_FORCE_X); -NODES[2603].Fix(BODY_FORCE_Y); -NODES[2603].Fix(BODY_FORCE_Z); -NODES[2604].Fix(BODY_FORCE_X); -NODES[2604].Fix(BODY_FORCE_Y); -NODES[2604].Fix(BODY_FORCE_Z); -NODES[2605].Fix(BODY_FORCE_X); -NODES[2605].Fix(BODY_FORCE_Y); -NODES[2605].Fix(BODY_FORCE_Z); -NODES[2606].Fix(BODY_FORCE_X); -NODES[2606].Fix(BODY_FORCE_Y); -NODES[2606].Fix(BODY_FORCE_Z); -NODES[2607].Fix(BODY_FORCE_X); -NODES[2607].Fix(BODY_FORCE_Y); -NODES[2607].Fix(BODY_FORCE_Z); -NODES[2608].Fix(BODY_FORCE_X); -NODES[2608].Fix(BODY_FORCE_Y); -NODES[2608].Fix(BODY_FORCE_Z); -NODES[2609].Fix(BODY_FORCE_X); -NODES[2609].Fix(BODY_FORCE_Y); -NODES[2609].Fix(BODY_FORCE_Z); -NODES[2610].Fix(BODY_FORCE_X); -NODES[2610].Fix(BODY_FORCE_Y); -NODES[2610].Fix(BODY_FORCE_Z); -NODES[2611].Fix(BODY_FORCE_X); -NODES[2611].Fix(BODY_FORCE_Y); -NODES[2611].Fix(BODY_FORCE_Z); -NODES[2613].Fix(BODY_FORCE_X); -NODES[2613].Fix(BODY_FORCE_Y); -NODES[2613].Fix(BODY_FORCE_Z); -NODES[2614].Fix(BODY_FORCE_X); -NODES[2614].Fix(BODY_FORCE_Y); -NODES[2614].Fix(BODY_FORCE_Z); -NODES[2615].Fix(BODY_FORCE_X); -NODES[2615].Fix(BODY_FORCE_Y); -NODES[2615].Fix(BODY_FORCE_Z); -NODES[2616].Fix(BODY_FORCE_X); -NODES[2616].Fix(BODY_FORCE_Y); -NODES[2616].Fix(BODY_FORCE_Z); -NODES[2617].Fix(BODY_FORCE_X); -NODES[2617].Fix(BODY_FORCE_Y); -NODES[2617].Fix(BODY_FORCE_Z); -NODES[2618].Fix(BODY_FORCE_X); -NODES[2618].Fix(BODY_FORCE_Y); -NODES[2618].Fix(BODY_FORCE_Z); -NODES[2619].Fix(BODY_FORCE_X); -NODES[2619].Fix(BODY_FORCE_Y); -NODES[2619].Fix(BODY_FORCE_Z); -NODES[2620].Fix(BODY_FORCE_X); -NODES[2620].Fix(BODY_FORCE_Y); -NODES[2620].Fix(BODY_FORCE_Z); -NODES[2621].Fix(BODY_FORCE_X); -NODES[2621].Fix(BODY_FORCE_Y); -NODES[2621].Fix(BODY_FORCE_Z); -NODES[2622].Fix(BODY_FORCE_X); -NODES[2622].Fix(BODY_FORCE_Y); -NODES[2622].Fix(BODY_FORCE_Z); -NODES[2623].Fix(BODY_FORCE_X); -NODES[2623].Fix(BODY_FORCE_Y); -NODES[2623].Fix(BODY_FORCE_Z); -NODES[2624].Fix(BODY_FORCE_X); -NODES[2624].Fix(BODY_FORCE_Y); -NODES[2624].Fix(BODY_FORCE_Z); -NODES[2625].Fix(BODY_FORCE_X); -NODES[2625].Fix(BODY_FORCE_Y); -NODES[2625].Fix(BODY_FORCE_Z); -NODES[2626].Fix(BODY_FORCE_X); -NODES[2626].Fix(BODY_FORCE_Y); -NODES[2626].Fix(BODY_FORCE_Z); -NODES[2627].Fix(BODY_FORCE_X); -NODES[2627].Fix(BODY_FORCE_Y); -NODES[2627].Fix(BODY_FORCE_Z); -NODES[2628].Fix(BODY_FORCE_X); -NODES[2628].Fix(BODY_FORCE_Y); -NODES[2628].Fix(BODY_FORCE_Z); -NODES[2629].Fix(BODY_FORCE_X); -NODES[2629].Fix(BODY_FORCE_Y); -NODES[2629].Fix(BODY_FORCE_Z); -NODES[2630].Fix(BODY_FORCE_X); -NODES[2630].Fix(BODY_FORCE_Y); -NODES[2630].Fix(BODY_FORCE_Z); -NODES[2631].Fix(BODY_FORCE_X); -NODES[2631].Fix(BODY_FORCE_Y); -NODES[2631].Fix(BODY_FORCE_Z); -NODES[2632].Fix(BODY_FORCE_X); -NODES[2632].Fix(BODY_FORCE_Y); -NODES[2632].Fix(BODY_FORCE_Z); -NODES[2633].Fix(BODY_FORCE_X); -NODES[2633].Fix(BODY_FORCE_Y); -NODES[2633].Fix(BODY_FORCE_Z); -NODES[2634].Fix(BODY_FORCE_X); -NODES[2634].Fix(BODY_FORCE_Y); -NODES[2634].Fix(BODY_FORCE_Z); -NODES[2635].Fix(BODY_FORCE_X); -NODES[2635].Fix(BODY_FORCE_Y); -NODES[2635].Fix(BODY_FORCE_Z); -NODES[2636].Fix(BODY_FORCE_X); -NODES[2636].Fix(BODY_FORCE_Y); -NODES[2636].Fix(BODY_FORCE_Z); -NODES[2637].Fix(BODY_FORCE_X); -NODES[2637].Fix(BODY_FORCE_Y); -NODES[2637].Fix(BODY_FORCE_Z); -NODES[2638].Fix(BODY_FORCE_X); -NODES[2638].Fix(BODY_FORCE_Y); -NODES[2638].Fix(BODY_FORCE_Z); -NODES[2639].Fix(BODY_FORCE_X); -NODES[2639].Fix(BODY_FORCE_Y); -NODES[2639].Fix(BODY_FORCE_Z); -NODES[2640].Fix(BODY_FORCE_X); -NODES[2640].Fix(BODY_FORCE_Y); -NODES[2640].Fix(BODY_FORCE_Z); -NODES[2641].Fix(BODY_FORCE_X); -NODES[2641].Fix(BODY_FORCE_Y); -NODES[2641].Fix(BODY_FORCE_Z); -NODES[2643].Fix(BODY_FORCE_X); -NODES[2643].Fix(BODY_FORCE_Y); -NODES[2643].Fix(BODY_FORCE_Z); -NODES[2644].Fix(BODY_FORCE_X); -NODES[2644].Fix(BODY_FORCE_Y); -NODES[2644].Fix(BODY_FORCE_Z); -NODES[2645].Fix(BODY_FORCE_X); -NODES[2645].Fix(BODY_FORCE_Y); -NODES[2645].Fix(BODY_FORCE_Z); -NODES[2646].Fix(BODY_FORCE_X); -NODES[2646].Fix(BODY_FORCE_Y); -NODES[2646].Fix(BODY_FORCE_Z); -NODES[2647].Fix(BODY_FORCE_X); -NODES[2647].Fix(BODY_FORCE_Y); -NODES[2647].Fix(BODY_FORCE_Z); -NODES[2648].Fix(BODY_FORCE_X); -NODES[2648].Fix(BODY_FORCE_Y); -NODES[2648].Fix(BODY_FORCE_Z); -NODES[2649].Fix(BODY_FORCE_X); -NODES[2649].Fix(BODY_FORCE_Y); -NODES[2649].Fix(BODY_FORCE_Z); -NODES[2650].Fix(BODY_FORCE_X); -NODES[2650].Fix(BODY_FORCE_Y); -NODES[2650].Fix(BODY_FORCE_Z); -NODES[2651].Fix(BODY_FORCE_X); -NODES[2651].Fix(BODY_FORCE_Y); -NODES[2651].Fix(BODY_FORCE_Z); -NODES[2652].Fix(BODY_FORCE_X); -NODES[2652].Fix(BODY_FORCE_Y); -NODES[2652].Fix(BODY_FORCE_Z); -NODES[2653].Fix(BODY_FORCE_X); -NODES[2653].Fix(BODY_FORCE_Y); -NODES[2653].Fix(BODY_FORCE_Z); -NODES[2654].Fix(BODY_FORCE_X); -NODES[2654].Fix(BODY_FORCE_Y); -NODES[2654].Fix(BODY_FORCE_Z); -NODES[2655].Fix(BODY_FORCE_X); -NODES[2655].Fix(BODY_FORCE_Y); -NODES[2655].Fix(BODY_FORCE_Z); -NODES[2656].Fix(BODY_FORCE_X); -NODES[2656].Fix(BODY_FORCE_Y); -NODES[2656].Fix(BODY_FORCE_Z); -NODES[2657].Fix(BODY_FORCE_X); -NODES[2657].Fix(BODY_FORCE_Y); -NODES[2657].Fix(BODY_FORCE_Z); -NODES[2658].Fix(BODY_FORCE_X); -NODES[2658].Fix(BODY_FORCE_Y); -NODES[2658].Fix(BODY_FORCE_Z); -NODES[2659].Fix(BODY_FORCE_X); -NODES[2659].Fix(BODY_FORCE_Y); -NODES[2659].Fix(BODY_FORCE_Z); -NODES[2660].Fix(BODY_FORCE_X); -NODES[2660].Fix(BODY_FORCE_Y); -NODES[2660].Fix(BODY_FORCE_Z); -NODES[2661].Fix(BODY_FORCE_X); -NODES[2661].Fix(BODY_FORCE_Y); -NODES[2661].Fix(BODY_FORCE_Z); -NODES[2662].Fix(BODY_FORCE_X); -NODES[2662].Fix(BODY_FORCE_Y); -NODES[2662].Fix(BODY_FORCE_Z); -NODES[2663].Fix(BODY_FORCE_X); -NODES[2663].Fix(BODY_FORCE_Y); -NODES[2663].Fix(BODY_FORCE_Z); -NODES[2664].Fix(BODY_FORCE_X); -NODES[2664].Fix(BODY_FORCE_Y); -NODES[2664].Fix(BODY_FORCE_Z); -NODES[2665].Fix(BODY_FORCE_X); -NODES[2665].Fix(BODY_FORCE_Y); -NODES[2665].Fix(BODY_FORCE_Z); -NODES[2666].Fix(BODY_FORCE_X); -NODES[2666].Fix(BODY_FORCE_Y); -NODES[2666].Fix(BODY_FORCE_Z); -NODES[2667].Fix(BODY_FORCE_X); -NODES[2667].Fix(BODY_FORCE_Y); -NODES[2667].Fix(BODY_FORCE_Z); -NODES[2668].Fix(BODY_FORCE_X); -NODES[2668].Fix(BODY_FORCE_Y); -NODES[2668].Fix(BODY_FORCE_Z); -NODES[2669].Fix(BODY_FORCE_X); -NODES[2669].Fix(BODY_FORCE_Y); -NODES[2669].Fix(BODY_FORCE_Z); -NODES[2670].Fix(BODY_FORCE_X); -NODES[2670].Fix(BODY_FORCE_Y); -NODES[2670].Fix(BODY_FORCE_Z); -NODES[2672].Fix(BODY_FORCE_X); -NODES[2672].Fix(BODY_FORCE_Y); -NODES[2672].Fix(BODY_FORCE_Z); -NODES[2673].Fix(BODY_FORCE_X); -NODES[2673].Fix(BODY_FORCE_Y); -NODES[2673].Fix(BODY_FORCE_Z); -NODES[2674].Fix(BODY_FORCE_X); -NODES[2674].Fix(BODY_FORCE_Y); -NODES[2674].Fix(BODY_FORCE_Z); -NODES[2675].Fix(BODY_FORCE_X); -NODES[2675].Fix(BODY_FORCE_Y); -NODES[2675].Fix(BODY_FORCE_Z); -NODES[2676].Fix(BODY_FORCE_X); -NODES[2676].Fix(BODY_FORCE_Y); -NODES[2676].Fix(BODY_FORCE_Z); -NODES[2677].Fix(BODY_FORCE_X); -NODES[2677].Fix(BODY_FORCE_Y); -NODES[2677].Fix(BODY_FORCE_Z); -NODES[2678].Fix(BODY_FORCE_X); -NODES[2678].Fix(BODY_FORCE_Y); -NODES[2678].Fix(BODY_FORCE_Z); -NODES[2679].Fix(BODY_FORCE_X); -NODES[2679].Fix(BODY_FORCE_Y); -NODES[2679].Fix(BODY_FORCE_Z); -NODES[2680].Fix(BODY_FORCE_X); -NODES[2680].Fix(BODY_FORCE_Y); -NODES[2680].Fix(BODY_FORCE_Z); -NODES[2681].Fix(BODY_FORCE_X); -NODES[2681].Fix(BODY_FORCE_Y); -NODES[2681].Fix(BODY_FORCE_Z); -NODES[2682].Fix(BODY_FORCE_X); -NODES[2682].Fix(BODY_FORCE_Y); -NODES[2682].Fix(BODY_FORCE_Z); -NODES[2683].Fix(BODY_FORCE_X); -NODES[2683].Fix(BODY_FORCE_Y); -NODES[2683].Fix(BODY_FORCE_Z); -NODES[2684].Fix(BODY_FORCE_X); -NODES[2684].Fix(BODY_FORCE_Y); -NODES[2684].Fix(BODY_FORCE_Z); -NODES[2685].Fix(BODY_FORCE_X); -NODES[2685].Fix(BODY_FORCE_Y); -NODES[2685].Fix(BODY_FORCE_Z); -NODES[2686].Fix(BODY_FORCE_X); -NODES[2686].Fix(BODY_FORCE_Y); -NODES[2686].Fix(BODY_FORCE_Z); -NODES[2687].Fix(BODY_FORCE_X); -NODES[2687].Fix(BODY_FORCE_Y); -NODES[2687].Fix(BODY_FORCE_Z); -NODES[2688].Fix(BODY_FORCE_X); -NODES[2688].Fix(BODY_FORCE_Y); -NODES[2688].Fix(BODY_FORCE_Z); -NODES[2689].Fix(BODY_FORCE_X); -NODES[2689].Fix(BODY_FORCE_Y); -NODES[2689].Fix(BODY_FORCE_Z); -NODES[2690].Fix(BODY_FORCE_X); -NODES[2690].Fix(BODY_FORCE_Y); -NODES[2690].Fix(BODY_FORCE_Z); -NODES[2691].Fix(BODY_FORCE_X); -NODES[2691].Fix(BODY_FORCE_Y); -NODES[2691].Fix(BODY_FORCE_Z); -NODES[2692].Fix(BODY_FORCE_X); -NODES[2692].Fix(BODY_FORCE_Y); -NODES[2692].Fix(BODY_FORCE_Z); -NODES[2693].Fix(BODY_FORCE_X); -NODES[2693].Fix(BODY_FORCE_Y); -NODES[2693].Fix(BODY_FORCE_Z); -NODES[2694].Fix(BODY_FORCE_X); -NODES[2694].Fix(BODY_FORCE_Y); -NODES[2694].Fix(BODY_FORCE_Z); -NODES[2695].Fix(BODY_FORCE_X); -NODES[2695].Fix(BODY_FORCE_Y); -NODES[2695].Fix(BODY_FORCE_Z); -NODES[2696].Fix(BODY_FORCE_X); -NODES[2696].Fix(BODY_FORCE_Y); -NODES[2696].Fix(BODY_FORCE_Z); -NODES[2697].Fix(BODY_FORCE_X); -NODES[2697].Fix(BODY_FORCE_Y); -NODES[2697].Fix(BODY_FORCE_Z); -NODES[2698].Fix(BODY_FORCE_X); -NODES[2698].Fix(BODY_FORCE_Y); -NODES[2698].Fix(BODY_FORCE_Z); -NODES[2699].Fix(BODY_FORCE_X); -NODES[2699].Fix(BODY_FORCE_Y); -NODES[2699].Fix(BODY_FORCE_Z); -NODES[2700].Fix(BODY_FORCE_X); -NODES[2700].Fix(BODY_FORCE_Y); -NODES[2700].Fix(BODY_FORCE_Z); -NODES[2701].Fix(BODY_FORCE_X); -NODES[2701].Fix(BODY_FORCE_Y); -NODES[2701].Fix(BODY_FORCE_Z); -NODES[2703].Fix(BODY_FORCE_X); -NODES[2703].Fix(BODY_FORCE_Y); -NODES[2703].Fix(BODY_FORCE_Z); -NODES[2704].Fix(BODY_FORCE_X); -NODES[2704].Fix(BODY_FORCE_Y); -NODES[2704].Fix(BODY_FORCE_Z); -NODES[2705].Fix(BODY_FORCE_X); -NODES[2705].Fix(BODY_FORCE_Y); -NODES[2705].Fix(BODY_FORCE_Z); -NODES[2706].Fix(BODY_FORCE_X); -NODES[2706].Fix(BODY_FORCE_Y); -NODES[2706].Fix(BODY_FORCE_Z); -NODES[2707].Fix(BODY_FORCE_X); -NODES[2707].Fix(BODY_FORCE_Y); -NODES[2707].Fix(BODY_FORCE_Z); -NODES[2708].Fix(BODY_FORCE_X); -NODES[2708].Fix(BODY_FORCE_Y); -NODES[2708].Fix(BODY_FORCE_Z); -NODES[2709].Fix(BODY_FORCE_X); -NODES[2709].Fix(BODY_FORCE_Y); -NODES[2709].Fix(BODY_FORCE_Z); -NODES[2710].Fix(BODY_FORCE_X); -NODES[2710].Fix(BODY_FORCE_Y); -NODES[2710].Fix(BODY_FORCE_Z); -NODES[2711].Fix(BODY_FORCE_X); -NODES[2711].Fix(BODY_FORCE_Y); -NODES[2711].Fix(BODY_FORCE_Z); -NODES[2712].Fix(BODY_FORCE_X); -NODES[2712].Fix(BODY_FORCE_Y); -NODES[2712].Fix(BODY_FORCE_Z); -NODES[2713].Fix(BODY_FORCE_X); -NODES[2713].Fix(BODY_FORCE_Y); -NODES[2713].Fix(BODY_FORCE_Z); -NODES[2714].Fix(BODY_FORCE_X); -NODES[2714].Fix(BODY_FORCE_Y); -NODES[2714].Fix(BODY_FORCE_Z); -NODES[2715].Fix(BODY_FORCE_X); -NODES[2715].Fix(BODY_FORCE_Y); -NODES[2715].Fix(BODY_FORCE_Z); -NODES[2716].Fix(BODY_FORCE_X); -NODES[2716].Fix(BODY_FORCE_Y); -NODES[2716].Fix(BODY_FORCE_Z); -NODES[2717].Fix(BODY_FORCE_X); -NODES[2717].Fix(BODY_FORCE_Y); -NODES[2717].Fix(BODY_FORCE_Z); -NODES[2718].Fix(BODY_FORCE_X); -NODES[2718].Fix(BODY_FORCE_Y); -NODES[2718].Fix(BODY_FORCE_Z); -NODES[2719].Fix(BODY_FORCE_X); -NODES[2719].Fix(BODY_FORCE_Y); -NODES[2719].Fix(BODY_FORCE_Z); -NODES[2720].Fix(BODY_FORCE_X); -NODES[2720].Fix(BODY_FORCE_Y); -NODES[2720].Fix(BODY_FORCE_Z); -NODES[2721].Fix(BODY_FORCE_X); -NODES[2721].Fix(BODY_FORCE_Y); -NODES[2721].Fix(BODY_FORCE_Z); -NODES[2722].Fix(BODY_FORCE_X); -NODES[2722].Fix(BODY_FORCE_Y); -NODES[2722].Fix(BODY_FORCE_Z); -NODES[2723].Fix(BODY_FORCE_X); -NODES[2723].Fix(BODY_FORCE_Y); -NODES[2723].Fix(BODY_FORCE_Z); -NODES[2724].Fix(BODY_FORCE_X); -NODES[2724].Fix(BODY_FORCE_Y); -NODES[2724].Fix(BODY_FORCE_Z); -NODES[2725].Fix(BODY_FORCE_X); -NODES[2725].Fix(BODY_FORCE_Y); -NODES[2725].Fix(BODY_FORCE_Z); -NODES[2726].Fix(BODY_FORCE_X); -NODES[2726].Fix(BODY_FORCE_Y); -NODES[2726].Fix(BODY_FORCE_Z); -NODES[2727].Fix(BODY_FORCE_X); -NODES[2727].Fix(BODY_FORCE_Y); -NODES[2727].Fix(BODY_FORCE_Z); -NODES[2728].Fix(BODY_FORCE_X); -NODES[2728].Fix(BODY_FORCE_Y); -NODES[2728].Fix(BODY_FORCE_Z); -NODES[2729].Fix(BODY_FORCE_X); -NODES[2729].Fix(BODY_FORCE_Y); -NODES[2729].Fix(BODY_FORCE_Z); -NODES[2730].Fix(BODY_FORCE_X); -NODES[2730].Fix(BODY_FORCE_Y); -NODES[2730].Fix(BODY_FORCE_Z); -NODES[2732].Fix(BODY_FORCE_X); -NODES[2732].Fix(BODY_FORCE_Y); -NODES[2732].Fix(BODY_FORCE_Z); -NODES[2733].Fix(BODY_FORCE_X); -NODES[2733].Fix(BODY_FORCE_Y); -NODES[2733].Fix(BODY_FORCE_Z); -NODES[2734].Fix(BODY_FORCE_X); -NODES[2734].Fix(BODY_FORCE_Y); -NODES[2734].Fix(BODY_FORCE_Z); -NODES[2735].Fix(BODY_FORCE_X); -NODES[2735].Fix(BODY_FORCE_Y); -NODES[2735].Fix(BODY_FORCE_Z); -NODES[2736].Fix(BODY_FORCE_X); -NODES[2736].Fix(BODY_FORCE_Y); -NODES[2736].Fix(BODY_FORCE_Z); -NODES[2737].Fix(BODY_FORCE_X); -NODES[2737].Fix(BODY_FORCE_Y); -NODES[2737].Fix(BODY_FORCE_Z); -NODES[2738].Fix(BODY_FORCE_X); -NODES[2738].Fix(BODY_FORCE_Y); -NODES[2738].Fix(BODY_FORCE_Z); -NODES[2739].Fix(BODY_FORCE_X); -NODES[2739].Fix(BODY_FORCE_Y); -NODES[2739].Fix(BODY_FORCE_Z); -NODES[2740].Fix(BODY_FORCE_X); -NODES[2740].Fix(BODY_FORCE_Y); -NODES[2740].Fix(BODY_FORCE_Z); -NODES[2741].Fix(BODY_FORCE_X); -NODES[2741].Fix(BODY_FORCE_Y); -NODES[2741].Fix(BODY_FORCE_Z); -NODES[2742].Fix(BODY_FORCE_X); -NODES[2742].Fix(BODY_FORCE_Y); -NODES[2742].Fix(BODY_FORCE_Z); -NODES[2743].Fix(BODY_FORCE_X); -NODES[2743].Fix(BODY_FORCE_Y); -NODES[2743].Fix(BODY_FORCE_Z); -NODES[2744].Fix(BODY_FORCE_X); -NODES[2744].Fix(BODY_FORCE_Y); -NODES[2744].Fix(BODY_FORCE_Z); -NODES[2745].Fix(BODY_FORCE_X); -NODES[2745].Fix(BODY_FORCE_Y); -NODES[2745].Fix(BODY_FORCE_Z); -NODES[2746].Fix(BODY_FORCE_X); -NODES[2746].Fix(BODY_FORCE_Y); -NODES[2746].Fix(BODY_FORCE_Z); -NODES[2747].Fix(BODY_FORCE_X); -NODES[2747].Fix(BODY_FORCE_Y); -NODES[2747].Fix(BODY_FORCE_Z); -NODES[2748].Fix(BODY_FORCE_X); -NODES[2748].Fix(BODY_FORCE_Y); -NODES[2748].Fix(BODY_FORCE_Z); -NODES[2749].Fix(BODY_FORCE_X); -NODES[2749].Fix(BODY_FORCE_Y); -NODES[2749].Fix(BODY_FORCE_Z); -NODES[2750].Fix(BODY_FORCE_X); -NODES[2750].Fix(BODY_FORCE_Y); -NODES[2750].Fix(BODY_FORCE_Z); -NODES[2751].Fix(BODY_FORCE_X); -NODES[2751].Fix(BODY_FORCE_Y); -NODES[2751].Fix(BODY_FORCE_Z); -NODES[2752].Fix(BODY_FORCE_X); -NODES[2752].Fix(BODY_FORCE_Y); -NODES[2752].Fix(BODY_FORCE_Z); -NODES[2753].Fix(BODY_FORCE_X); -NODES[2753].Fix(BODY_FORCE_Y); -NODES[2753].Fix(BODY_FORCE_Z); -NODES[2754].Fix(BODY_FORCE_X); -NODES[2754].Fix(BODY_FORCE_Y); -NODES[2754].Fix(BODY_FORCE_Z); -NODES[2755].Fix(BODY_FORCE_X); -NODES[2755].Fix(BODY_FORCE_Y); -NODES[2755].Fix(BODY_FORCE_Z); -NODES[2756].Fix(BODY_FORCE_X); -NODES[2756].Fix(BODY_FORCE_Y); -NODES[2756].Fix(BODY_FORCE_Z); -NODES[2757].Fix(BODY_FORCE_X); -NODES[2757].Fix(BODY_FORCE_Y); -NODES[2757].Fix(BODY_FORCE_Z); -NODES[2758].Fix(BODY_FORCE_X); -NODES[2758].Fix(BODY_FORCE_Y); -NODES[2758].Fix(BODY_FORCE_Z); -NODES[2759].Fix(BODY_FORCE_X); -NODES[2759].Fix(BODY_FORCE_Y); -NODES[2759].Fix(BODY_FORCE_Z); -NODES[2761].Fix(BODY_FORCE_X); -NODES[2761].Fix(BODY_FORCE_Y); -NODES[2761].Fix(BODY_FORCE_Z); -NODES[2762].Fix(BODY_FORCE_X); -NODES[2762].Fix(BODY_FORCE_Y); -NODES[2762].Fix(BODY_FORCE_Z); -NODES[2763].Fix(BODY_FORCE_X); -NODES[2763].Fix(BODY_FORCE_Y); -NODES[2763].Fix(BODY_FORCE_Z); -NODES[2764].Fix(BODY_FORCE_X); -NODES[2764].Fix(BODY_FORCE_Y); -NODES[2764].Fix(BODY_FORCE_Z); -NODES[2765].Fix(BODY_FORCE_X); -NODES[2765].Fix(BODY_FORCE_Y); -NODES[2765].Fix(BODY_FORCE_Z); -NODES[2766].Fix(BODY_FORCE_X); -NODES[2766].Fix(BODY_FORCE_Y); -NODES[2766].Fix(BODY_FORCE_Z); -NODES[2767].Fix(BODY_FORCE_X); -NODES[2767].Fix(BODY_FORCE_Y); -NODES[2767].Fix(BODY_FORCE_Z); -NODES[2768].Fix(BODY_FORCE_X); -NODES[2768].Fix(BODY_FORCE_Y); -NODES[2768].Fix(BODY_FORCE_Z); -NODES[2769].Fix(BODY_FORCE_X); -NODES[2769].Fix(BODY_FORCE_Y); -NODES[2769].Fix(BODY_FORCE_Z); -NODES[2770].Fix(BODY_FORCE_X); -NODES[2770].Fix(BODY_FORCE_Y); -NODES[2770].Fix(BODY_FORCE_Z); -NODES[2771].Fix(BODY_FORCE_X); -NODES[2771].Fix(BODY_FORCE_Y); -NODES[2771].Fix(BODY_FORCE_Z); -NODES[2772].Fix(BODY_FORCE_X); -NODES[2772].Fix(BODY_FORCE_Y); -NODES[2772].Fix(BODY_FORCE_Z); -NODES[2773].Fix(BODY_FORCE_X); -NODES[2773].Fix(BODY_FORCE_Y); -NODES[2773].Fix(BODY_FORCE_Z); -NODES[2774].Fix(BODY_FORCE_X); -NODES[2774].Fix(BODY_FORCE_Y); -NODES[2774].Fix(BODY_FORCE_Z); -NODES[2775].Fix(BODY_FORCE_X); -NODES[2775].Fix(BODY_FORCE_Y); -NODES[2775].Fix(BODY_FORCE_Z); -NODES[2776].Fix(BODY_FORCE_X); -NODES[2776].Fix(BODY_FORCE_Y); -NODES[2776].Fix(BODY_FORCE_Z); -NODES[2777].Fix(BODY_FORCE_X); -NODES[2777].Fix(BODY_FORCE_Y); -NODES[2777].Fix(BODY_FORCE_Z); -NODES[2778].Fix(BODY_FORCE_X); -NODES[2778].Fix(BODY_FORCE_Y); -NODES[2778].Fix(BODY_FORCE_Z); -NODES[2779].Fix(BODY_FORCE_X); -NODES[2779].Fix(BODY_FORCE_Y); -NODES[2779].Fix(BODY_FORCE_Z); -NODES[2780].Fix(BODY_FORCE_X); -NODES[2780].Fix(BODY_FORCE_Y); -NODES[2780].Fix(BODY_FORCE_Z); -NODES[2781].Fix(BODY_FORCE_X); -NODES[2781].Fix(BODY_FORCE_Y); -NODES[2781].Fix(BODY_FORCE_Z); -NODES[2782].Fix(BODY_FORCE_X); -NODES[2782].Fix(BODY_FORCE_Y); -NODES[2782].Fix(BODY_FORCE_Z); -NODES[2783].Fix(BODY_FORCE_X); -NODES[2783].Fix(BODY_FORCE_Y); -NODES[2783].Fix(BODY_FORCE_Z); -NODES[2784].Fix(BODY_FORCE_X); -NODES[2784].Fix(BODY_FORCE_Y); -NODES[2784].Fix(BODY_FORCE_Z); -NODES[2785].Fix(BODY_FORCE_X); -NODES[2785].Fix(BODY_FORCE_Y); -NODES[2785].Fix(BODY_FORCE_Z); -NODES[2786].Fix(BODY_FORCE_X); -NODES[2786].Fix(BODY_FORCE_Y); -NODES[2786].Fix(BODY_FORCE_Z); -NODES[2787].Fix(BODY_FORCE_X); -NODES[2787].Fix(BODY_FORCE_Y); -NODES[2787].Fix(BODY_FORCE_Z); -NODES[2789].Fix(BODY_FORCE_X); -NODES[2789].Fix(BODY_FORCE_Y); -NODES[2789].Fix(BODY_FORCE_Z); -NODES[2790].Fix(BODY_FORCE_X); -NODES[2790].Fix(BODY_FORCE_Y); -NODES[2790].Fix(BODY_FORCE_Z); -NODES[2791].Fix(BODY_FORCE_X); -NODES[2791].Fix(BODY_FORCE_Y); -NODES[2791].Fix(BODY_FORCE_Z); -NODES[2792].Fix(BODY_FORCE_X); -NODES[2792].Fix(BODY_FORCE_Y); -NODES[2792].Fix(BODY_FORCE_Z); -NODES[2793].Fix(BODY_FORCE_X); -NODES[2793].Fix(BODY_FORCE_Y); -NODES[2793].Fix(BODY_FORCE_Z); -NODES[2794].Fix(BODY_FORCE_X); -NODES[2794].Fix(BODY_FORCE_Y); -NODES[2794].Fix(BODY_FORCE_Z); -NODES[2795].Fix(BODY_FORCE_X); -NODES[2795].Fix(BODY_FORCE_Y); -NODES[2795].Fix(BODY_FORCE_Z); -NODES[2796].Fix(BODY_FORCE_X); -NODES[2796].Fix(BODY_FORCE_Y); -NODES[2796].Fix(BODY_FORCE_Z); -NODES[2797].Fix(BODY_FORCE_X); -NODES[2797].Fix(BODY_FORCE_Y); -NODES[2797].Fix(BODY_FORCE_Z); -NODES[2798].Fix(BODY_FORCE_X); -NODES[2798].Fix(BODY_FORCE_Y); -NODES[2798].Fix(BODY_FORCE_Z); -NODES[2799].Fix(BODY_FORCE_X); -NODES[2799].Fix(BODY_FORCE_Y); -NODES[2799].Fix(BODY_FORCE_Z); -NODES[2800].Fix(BODY_FORCE_X); -NODES[2800].Fix(BODY_FORCE_Y); -NODES[2800].Fix(BODY_FORCE_Z); -NODES[2801].Fix(BODY_FORCE_X); -NODES[2801].Fix(BODY_FORCE_Y); -NODES[2801].Fix(BODY_FORCE_Z); -NODES[2802].Fix(BODY_FORCE_X); -NODES[2802].Fix(BODY_FORCE_Y); -NODES[2802].Fix(BODY_FORCE_Z); -NODES[2803].Fix(BODY_FORCE_X); -NODES[2803].Fix(BODY_FORCE_Y); -NODES[2803].Fix(BODY_FORCE_Z); -NODES[2804].Fix(BODY_FORCE_X); -NODES[2804].Fix(BODY_FORCE_Y); -NODES[2804].Fix(BODY_FORCE_Z); -NODES[2805].Fix(BODY_FORCE_X); -NODES[2805].Fix(BODY_FORCE_Y); -NODES[2805].Fix(BODY_FORCE_Z); -NODES[2806].Fix(BODY_FORCE_X); -NODES[2806].Fix(BODY_FORCE_Y); -NODES[2806].Fix(BODY_FORCE_Z); -NODES[2807].Fix(BODY_FORCE_X); -NODES[2807].Fix(BODY_FORCE_Y); -NODES[2807].Fix(BODY_FORCE_Z); -NODES[2808].Fix(BODY_FORCE_X); -NODES[2808].Fix(BODY_FORCE_Y); -NODES[2808].Fix(BODY_FORCE_Z); -NODES[2809].Fix(BODY_FORCE_X); -NODES[2809].Fix(BODY_FORCE_Y); -NODES[2809].Fix(BODY_FORCE_Z); -NODES[2810].Fix(BODY_FORCE_X); -NODES[2810].Fix(BODY_FORCE_Y); -NODES[2810].Fix(BODY_FORCE_Z); -NODES[2811].Fix(BODY_FORCE_X); -NODES[2811].Fix(BODY_FORCE_Y); -NODES[2811].Fix(BODY_FORCE_Z); -NODES[2812].Fix(BODY_FORCE_X); -NODES[2812].Fix(BODY_FORCE_Y); -NODES[2812].Fix(BODY_FORCE_Z); -NODES[2813].Fix(BODY_FORCE_X); -NODES[2813].Fix(BODY_FORCE_Y); -NODES[2813].Fix(BODY_FORCE_Z); -NODES[2814].Fix(BODY_FORCE_X); -NODES[2814].Fix(BODY_FORCE_Y); -NODES[2814].Fix(BODY_FORCE_Z); -NODES[2815].Fix(BODY_FORCE_X); -NODES[2815].Fix(BODY_FORCE_Y); -NODES[2815].Fix(BODY_FORCE_Z); -NODES[2816].Fix(BODY_FORCE_X); -NODES[2816].Fix(BODY_FORCE_Y); -NODES[2816].Fix(BODY_FORCE_Z); -NODES[2818].Fix(BODY_FORCE_X); -NODES[2818].Fix(BODY_FORCE_Y); -NODES[2818].Fix(BODY_FORCE_Z); -NODES[2819].Fix(BODY_FORCE_X); -NODES[2819].Fix(BODY_FORCE_Y); -NODES[2819].Fix(BODY_FORCE_Z); -NODES[2820].Fix(BODY_FORCE_X); -NODES[2820].Fix(BODY_FORCE_Y); -NODES[2820].Fix(BODY_FORCE_Z); -NODES[2821].Fix(BODY_FORCE_X); -NODES[2821].Fix(BODY_FORCE_Y); -NODES[2821].Fix(BODY_FORCE_Z); -NODES[2822].Fix(BODY_FORCE_X); -NODES[2822].Fix(BODY_FORCE_Y); -NODES[2822].Fix(BODY_FORCE_Z); -NODES[2823].Fix(BODY_FORCE_X); -NODES[2823].Fix(BODY_FORCE_Y); -NODES[2823].Fix(BODY_FORCE_Z); -NODES[2824].Fix(BODY_FORCE_X); -NODES[2824].Fix(BODY_FORCE_Y); -NODES[2824].Fix(BODY_FORCE_Z); -NODES[2825].Fix(BODY_FORCE_X); -NODES[2825].Fix(BODY_FORCE_Y); -NODES[2825].Fix(BODY_FORCE_Z); -NODES[2826].Fix(BODY_FORCE_X); -NODES[2826].Fix(BODY_FORCE_Y); -NODES[2826].Fix(BODY_FORCE_Z); -NODES[2827].Fix(BODY_FORCE_X); -NODES[2827].Fix(BODY_FORCE_Y); -NODES[2827].Fix(BODY_FORCE_Z); -NODES[2828].Fix(BODY_FORCE_X); -NODES[2828].Fix(BODY_FORCE_Y); -NODES[2828].Fix(BODY_FORCE_Z); -NODES[2829].Fix(BODY_FORCE_X); -NODES[2829].Fix(BODY_FORCE_Y); -NODES[2829].Fix(BODY_FORCE_Z); -NODES[2830].Fix(BODY_FORCE_X); -NODES[2830].Fix(BODY_FORCE_Y); -NODES[2830].Fix(BODY_FORCE_Z); -NODES[2831].Fix(BODY_FORCE_X); -NODES[2831].Fix(BODY_FORCE_Y); -NODES[2831].Fix(BODY_FORCE_Z); -NODES[2832].Fix(BODY_FORCE_X); -NODES[2832].Fix(BODY_FORCE_Y); -NODES[2832].Fix(BODY_FORCE_Z); -NODES[2833].Fix(BODY_FORCE_X); -NODES[2833].Fix(BODY_FORCE_Y); -NODES[2833].Fix(BODY_FORCE_Z); -NODES[2834].Fix(BODY_FORCE_X); -NODES[2834].Fix(BODY_FORCE_Y); -NODES[2834].Fix(BODY_FORCE_Z); -NODES[2835].Fix(BODY_FORCE_X); -NODES[2835].Fix(BODY_FORCE_Y); -NODES[2835].Fix(BODY_FORCE_Z); -NODES[2836].Fix(BODY_FORCE_X); -NODES[2836].Fix(BODY_FORCE_Y); -NODES[2836].Fix(BODY_FORCE_Z); -NODES[2837].Fix(BODY_FORCE_X); -NODES[2837].Fix(BODY_FORCE_Y); -NODES[2837].Fix(BODY_FORCE_Z); -NODES[2838].Fix(BODY_FORCE_X); -NODES[2838].Fix(BODY_FORCE_Y); -NODES[2838].Fix(BODY_FORCE_Z); -NODES[2839].Fix(BODY_FORCE_X); -NODES[2839].Fix(BODY_FORCE_Y); -NODES[2839].Fix(BODY_FORCE_Z); -NODES[2840].Fix(BODY_FORCE_X); -NODES[2840].Fix(BODY_FORCE_Y); -NODES[2840].Fix(BODY_FORCE_Z); -NODES[2841].Fix(BODY_FORCE_X); -NODES[2841].Fix(BODY_FORCE_Y); -NODES[2841].Fix(BODY_FORCE_Z); -NODES[2842].Fix(BODY_FORCE_X); -NODES[2842].Fix(BODY_FORCE_Y); -NODES[2842].Fix(BODY_FORCE_Z); -NODES[2843].Fix(BODY_FORCE_X); -NODES[2843].Fix(BODY_FORCE_Y); -NODES[2843].Fix(BODY_FORCE_Z); -NODES[2844].Fix(BODY_FORCE_X); -NODES[2844].Fix(BODY_FORCE_Y); -NODES[2844].Fix(BODY_FORCE_Z); -NODES[2845].Fix(BODY_FORCE_X); -NODES[2845].Fix(BODY_FORCE_Y); -NODES[2845].Fix(BODY_FORCE_Z); -NODES[2846].Fix(BODY_FORCE_X); -NODES[2846].Fix(BODY_FORCE_Y); -NODES[2846].Fix(BODY_FORCE_Z); -NODES[2847].Fix(BODY_FORCE_X); -NODES[2847].Fix(BODY_FORCE_Y); -NODES[2847].Fix(BODY_FORCE_Z); -NODES[2849].Fix(BODY_FORCE_X); -NODES[2849].Fix(BODY_FORCE_Y); -NODES[2849].Fix(BODY_FORCE_Z); -NODES[2850].Fix(BODY_FORCE_X); -NODES[2850].Fix(BODY_FORCE_Y); -NODES[2850].Fix(BODY_FORCE_Z); -NODES[2851].Fix(BODY_FORCE_X); -NODES[2851].Fix(BODY_FORCE_Y); -NODES[2851].Fix(BODY_FORCE_Z); -NODES[2852].Fix(BODY_FORCE_X); -NODES[2852].Fix(BODY_FORCE_Y); -NODES[2852].Fix(BODY_FORCE_Z); -NODES[2853].Fix(BODY_FORCE_X); -NODES[2853].Fix(BODY_FORCE_Y); -NODES[2853].Fix(BODY_FORCE_Z); -NODES[2854].Fix(BODY_FORCE_X); -NODES[2854].Fix(BODY_FORCE_Y); -NODES[2854].Fix(BODY_FORCE_Z); -NODES[2855].Fix(BODY_FORCE_X); -NODES[2855].Fix(BODY_FORCE_Y); -NODES[2855].Fix(BODY_FORCE_Z); -NODES[2856].Fix(BODY_FORCE_X); -NODES[2856].Fix(BODY_FORCE_Y); -NODES[2856].Fix(BODY_FORCE_Z); -NODES[2857].Fix(BODY_FORCE_X); -NODES[2857].Fix(BODY_FORCE_Y); -NODES[2857].Fix(BODY_FORCE_Z); -NODES[2858].Fix(BODY_FORCE_X); -NODES[2858].Fix(BODY_FORCE_Y); -NODES[2858].Fix(BODY_FORCE_Z); -NODES[2859].Fix(BODY_FORCE_X); -NODES[2859].Fix(BODY_FORCE_Y); -NODES[2859].Fix(BODY_FORCE_Z); -NODES[2860].Fix(BODY_FORCE_X); -NODES[2860].Fix(BODY_FORCE_Y); -NODES[2860].Fix(BODY_FORCE_Z); -NODES[2861].Fix(BODY_FORCE_X); -NODES[2861].Fix(BODY_FORCE_Y); -NODES[2861].Fix(BODY_FORCE_Z); -NODES[2862].Fix(BODY_FORCE_X); -NODES[2862].Fix(BODY_FORCE_Y); -NODES[2862].Fix(BODY_FORCE_Z); -NODES[2863].Fix(BODY_FORCE_X); -NODES[2863].Fix(BODY_FORCE_Y); -NODES[2863].Fix(BODY_FORCE_Z); -NODES[2864].Fix(BODY_FORCE_X); -NODES[2864].Fix(BODY_FORCE_Y); -NODES[2864].Fix(BODY_FORCE_Z); -NODES[2865].Fix(BODY_FORCE_X); -NODES[2865].Fix(BODY_FORCE_Y); -NODES[2865].Fix(BODY_FORCE_Z); -NODES[2866].Fix(BODY_FORCE_X); -NODES[2866].Fix(BODY_FORCE_Y); -NODES[2866].Fix(BODY_FORCE_Z); -NODES[2867].Fix(BODY_FORCE_X); -NODES[2867].Fix(BODY_FORCE_Y); -NODES[2867].Fix(BODY_FORCE_Z); -NODES[2868].Fix(BODY_FORCE_X); -NODES[2868].Fix(BODY_FORCE_Y); -NODES[2868].Fix(BODY_FORCE_Z); -NODES[2869].Fix(BODY_FORCE_X); -NODES[2869].Fix(BODY_FORCE_Y); -NODES[2869].Fix(BODY_FORCE_Z); -NODES[2870].Fix(BODY_FORCE_X); -NODES[2870].Fix(BODY_FORCE_Y); -NODES[2870].Fix(BODY_FORCE_Z); -NODES[2871].Fix(BODY_FORCE_X); -NODES[2871].Fix(BODY_FORCE_Y); -NODES[2871].Fix(BODY_FORCE_Z); -NODES[2872].Fix(BODY_FORCE_X); -NODES[2872].Fix(BODY_FORCE_Y); -NODES[2872].Fix(BODY_FORCE_Z); -NODES[2873].Fix(BODY_FORCE_X); -NODES[2873].Fix(BODY_FORCE_Y); -NODES[2873].Fix(BODY_FORCE_Z); -NODES[2874].Fix(BODY_FORCE_X); -NODES[2874].Fix(BODY_FORCE_Y); -NODES[2874].Fix(BODY_FORCE_Z); -NODES[2875].Fix(BODY_FORCE_X); -NODES[2875].Fix(BODY_FORCE_Y); -NODES[2875].Fix(BODY_FORCE_Z); -NODES[2876].Fix(BODY_FORCE_X); -NODES[2876].Fix(BODY_FORCE_Y); -NODES[2876].Fix(BODY_FORCE_Z); -NODES[2877].Fix(BODY_FORCE_X); -NODES[2877].Fix(BODY_FORCE_Y); -NODES[2877].Fix(BODY_FORCE_Z); -NODES[2879].Fix(BODY_FORCE_X); -NODES[2879].Fix(BODY_FORCE_Y); -NODES[2879].Fix(BODY_FORCE_Z); -NODES[2880].Fix(BODY_FORCE_X); -NODES[2880].Fix(BODY_FORCE_Y); -NODES[2880].Fix(BODY_FORCE_Z); -NODES[2881].Fix(BODY_FORCE_X); -NODES[2881].Fix(BODY_FORCE_Y); -NODES[2881].Fix(BODY_FORCE_Z); -NODES[2882].Fix(BODY_FORCE_X); -NODES[2882].Fix(BODY_FORCE_Y); -NODES[2882].Fix(BODY_FORCE_Z); -NODES[2883].Fix(BODY_FORCE_X); -NODES[2883].Fix(BODY_FORCE_Y); -NODES[2883].Fix(BODY_FORCE_Z); -NODES[2884].Fix(BODY_FORCE_X); -NODES[2884].Fix(BODY_FORCE_Y); -NODES[2884].Fix(BODY_FORCE_Z); -NODES[2885].Fix(BODY_FORCE_X); -NODES[2885].Fix(BODY_FORCE_Y); -NODES[2885].Fix(BODY_FORCE_Z); -NODES[2886].Fix(BODY_FORCE_X); -NODES[2886].Fix(BODY_FORCE_Y); -NODES[2886].Fix(BODY_FORCE_Z); -NODES[2887].Fix(BODY_FORCE_X); -NODES[2887].Fix(BODY_FORCE_Y); -NODES[2887].Fix(BODY_FORCE_Z); -NODES[2888].Fix(BODY_FORCE_X); -NODES[2888].Fix(BODY_FORCE_Y); -NODES[2888].Fix(BODY_FORCE_Z); -NODES[2889].Fix(BODY_FORCE_X); -NODES[2889].Fix(BODY_FORCE_Y); -NODES[2889].Fix(BODY_FORCE_Z); -NODES[2890].Fix(BODY_FORCE_X); -NODES[2890].Fix(BODY_FORCE_Y); -NODES[2890].Fix(BODY_FORCE_Z); -NODES[2891].Fix(BODY_FORCE_X); -NODES[2891].Fix(BODY_FORCE_Y); -NODES[2891].Fix(BODY_FORCE_Z); -NODES[2892].Fix(BODY_FORCE_X); -NODES[2892].Fix(BODY_FORCE_Y); -NODES[2892].Fix(BODY_FORCE_Z); -NODES[2893].Fix(BODY_FORCE_X); -NODES[2893].Fix(BODY_FORCE_Y); -NODES[2893].Fix(BODY_FORCE_Z); -NODES[2894].Fix(BODY_FORCE_X); -NODES[2894].Fix(BODY_FORCE_Y); -NODES[2894].Fix(BODY_FORCE_Z); -NODES[2895].Fix(BODY_FORCE_X); -NODES[2895].Fix(BODY_FORCE_Y); -NODES[2895].Fix(BODY_FORCE_Z); -NODES[2896].Fix(BODY_FORCE_X); -NODES[2896].Fix(BODY_FORCE_Y); -NODES[2896].Fix(BODY_FORCE_Z); -NODES[2897].Fix(BODY_FORCE_X); -NODES[2897].Fix(BODY_FORCE_Y); -NODES[2897].Fix(BODY_FORCE_Z); -NODES[2898].Fix(BODY_FORCE_X); -NODES[2898].Fix(BODY_FORCE_Y); -NODES[2898].Fix(BODY_FORCE_Z); -NODES[2899].Fix(BODY_FORCE_X); -NODES[2899].Fix(BODY_FORCE_Y); -NODES[2899].Fix(BODY_FORCE_Z); -NODES[2900].Fix(BODY_FORCE_X); -NODES[2900].Fix(BODY_FORCE_Y); -NODES[2900].Fix(BODY_FORCE_Z); -NODES[2901].Fix(BODY_FORCE_X); -NODES[2901].Fix(BODY_FORCE_Y); -NODES[2901].Fix(BODY_FORCE_Z); -NODES[2902].Fix(BODY_FORCE_X); -NODES[2902].Fix(BODY_FORCE_Y); -NODES[2902].Fix(BODY_FORCE_Z); -NODES[2903].Fix(BODY_FORCE_X); -NODES[2903].Fix(BODY_FORCE_Y); -NODES[2903].Fix(BODY_FORCE_Z); -NODES[2904].Fix(BODY_FORCE_X); -NODES[2904].Fix(BODY_FORCE_Y); -NODES[2904].Fix(BODY_FORCE_Z); -NODES[2906].Fix(BODY_FORCE_X); -NODES[2906].Fix(BODY_FORCE_Y); -NODES[2906].Fix(BODY_FORCE_Z); -NODES[2907].Fix(BODY_FORCE_X); -NODES[2907].Fix(BODY_FORCE_Y); -NODES[2907].Fix(BODY_FORCE_Z); -NODES[2908].Fix(BODY_FORCE_X); -NODES[2908].Fix(BODY_FORCE_Y); -NODES[2908].Fix(BODY_FORCE_Z); -NODES[2909].Fix(BODY_FORCE_X); -NODES[2909].Fix(BODY_FORCE_Y); -NODES[2909].Fix(BODY_FORCE_Z); -NODES[2910].Fix(BODY_FORCE_X); -NODES[2910].Fix(BODY_FORCE_Y); -NODES[2910].Fix(BODY_FORCE_Z); -NODES[2911].Fix(BODY_FORCE_X); -NODES[2911].Fix(BODY_FORCE_Y); -NODES[2911].Fix(BODY_FORCE_Z); -NODES[2912].Fix(BODY_FORCE_X); -NODES[2912].Fix(BODY_FORCE_Y); -NODES[2912].Fix(BODY_FORCE_Z); -NODES[2913].Fix(BODY_FORCE_X); -NODES[2913].Fix(BODY_FORCE_Y); -NODES[2913].Fix(BODY_FORCE_Z); -NODES[2914].Fix(BODY_FORCE_X); -NODES[2914].Fix(BODY_FORCE_Y); -NODES[2914].Fix(BODY_FORCE_Z); -NODES[2915].Fix(BODY_FORCE_X); -NODES[2915].Fix(BODY_FORCE_Y); -NODES[2915].Fix(BODY_FORCE_Z); -NODES[2916].Fix(BODY_FORCE_X); -NODES[2916].Fix(BODY_FORCE_Y); -NODES[2916].Fix(BODY_FORCE_Z); -NODES[2917].Fix(BODY_FORCE_X); -NODES[2917].Fix(BODY_FORCE_Y); -NODES[2917].Fix(BODY_FORCE_Z); -NODES[2918].Fix(BODY_FORCE_X); -NODES[2918].Fix(BODY_FORCE_Y); -NODES[2918].Fix(BODY_FORCE_Z); -NODES[2919].Fix(BODY_FORCE_X); -NODES[2919].Fix(BODY_FORCE_Y); -NODES[2919].Fix(BODY_FORCE_Z); -NODES[2920].Fix(BODY_FORCE_X); -NODES[2920].Fix(BODY_FORCE_Y); -NODES[2920].Fix(BODY_FORCE_Z); -NODES[2921].Fix(BODY_FORCE_X); -NODES[2921].Fix(BODY_FORCE_Y); -NODES[2921].Fix(BODY_FORCE_Z); -NODES[2922].Fix(BODY_FORCE_X); -NODES[2922].Fix(BODY_FORCE_Y); -NODES[2922].Fix(BODY_FORCE_Z); -NODES[2923].Fix(BODY_FORCE_X); -NODES[2923].Fix(BODY_FORCE_Y); -NODES[2923].Fix(BODY_FORCE_Z); -NODES[2924].Fix(BODY_FORCE_X); -NODES[2924].Fix(BODY_FORCE_Y); -NODES[2924].Fix(BODY_FORCE_Z); -NODES[2925].Fix(BODY_FORCE_X); -NODES[2925].Fix(BODY_FORCE_Y); -NODES[2925].Fix(BODY_FORCE_Z); -NODES[2926].Fix(BODY_FORCE_X); -NODES[2926].Fix(BODY_FORCE_Y); -NODES[2926].Fix(BODY_FORCE_Z); -NODES[2927].Fix(BODY_FORCE_X); -NODES[2927].Fix(BODY_FORCE_Y); -NODES[2927].Fix(BODY_FORCE_Z); -NODES[2928].Fix(BODY_FORCE_X); -NODES[2928].Fix(BODY_FORCE_Y); -NODES[2928].Fix(BODY_FORCE_Z); -NODES[2929].Fix(BODY_FORCE_X); -NODES[2929].Fix(BODY_FORCE_Y); -NODES[2929].Fix(BODY_FORCE_Z); -NODES[2930].Fix(BODY_FORCE_X); -NODES[2930].Fix(BODY_FORCE_Y); -NODES[2930].Fix(BODY_FORCE_Z); -NODES[2931].Fix(BODY_FORCE_X); -NODES[2931].Fix(BODY_FORCE_Y); -NODES[2931].Fix(BODY_FORCE_Z); -NODES[2933].Fix(BODY_FORCE_X); -NODES[2933].Fix(BODY_FORCE_Y); -NODES[2933].Fix(BODY_FORCE_Z); -NODES[2934].Fix(BODY_FORCE_X); -NODES[2934].Fix(BODY_FORCE_Y); -NODES[2934].Fix(BODY_FORCE_Z); -NODES[2935].Fix(BODY_FORCE_X); -NODES[2935].Fix(BODY_FORCE_Y); -NODES[2935].Fix(BODY_FORCE_Z); -NODES[2936].Fix(BODY_FORCE_X); -NODES[2936].Fix(BODY_FORCE_Y); -NODES[2936].Fix(BODY_FORCE_Z); -NODES[2937].Fix(BODY_FORCE_X); -NODES[2937].Fix(BODY_FORCE_Y); -NODES[2937].Fix(BODY_FORCE_Z); -NODES[2938].Fix(BODY_FORCE_X); -NODES[2938].Fix(BODY_FORCE_Y); -NODES[2938].Fix(BODY_FORCE_Z); -NODES[2939].Fix(BODY_FORCE_X); -NODES[2939].Fix(BODY_FORCE_Y); -NODES[2939].Fix(BODY_FORCE_Z); -NODES[2940].Fix(BODY_FORCE_X); -NODES[2940].Fix(BODY_FORCE_Y); -NODES[2940].Fix(BODY_FORCE_Z); -NODES[2941].Fix(BODY_FORCE_X); -NODES[2941].Fix(BODY_FORCE_Y); -NODES[2941].Fix(BODY_FORCE_Z); -NODES[2942].Fix(BODY_FORCE_X); -NODES[2942].Fix(BODY_FORCE_Y); -NODES[2942].Fix(BODY_FORCE_Z); -NODES[2943].Fix(BODY_FORCE_X); -NODES[2943].Fix(BODY_FORCE_Y); -NODES[2943].Fix(BODY_FORCE_Z); -NODES[2944].Fix(BODY_FORCE_X); -NODES[2944].Fix(BODY_FORCE_Y); -NODES[2944].Fix(BODY_FORCE_Z); -NODES[2945].Fix(BODY_FORCE_X); -NODES[2945].Fix(BODY_FORCE_Y); -NODES[2945].Fix(BODY_FORCE_Z); -NODES[2946].Fix(BODY_FORCE_X); -NODES[2946].Fix(BODY_FORCE_Y); -NODES[2946].Fix(BODY_FORCE_Z); -NODES[2947].Fix(BODY_FORCE_X); -NODES[2947].Fix(BODY_FORCE_Y); -NODES[2947].Fix(BODY_FORCE_Z); -NODES[2948].Fix(BODY_FORCE_X); -NODES[2948].Fix(BODY_FORCE_Y); -NODES[2948].Fix(BODY_FORCE_Z); -NODES[2949].Fix(BODY_FORCE_X); -NODES[2949].Fix(BODY_FORCE_Y); -NODES[2949].Fix(BODY_FORCE_Z); -NODES[2950].Fix(BODY_FORCE_X); -NODES[2950].Fix(BODY_FORCE_Y); -NODES[2950].Fix(BODY_FORCE_Z); -NODES[2951].Fix(BODY_FORCE_X); -NODES[2951].Fix(BODY_FORCE_Y); -NODES[2951].Fix(BODY_FORCE_Z); -NODES[2952].Fix(BODY_FORCE_X); -NODES[2952].Fix(BODY_FORCE_Y); -NODES[2952].Fix(BODY_FORCE_Z); -NODES[2953].Fix(BODY_FORCE_X); -NODES[2953].Fix(BODY_FORCE_Y); -NODES[2953].Fix(BODY_FORCE_Z); -NODES[2954].Fix(BODY_FORCE_X); -NODES[2954].Fix(BODY_FORCE_Y); -NODES[2954].Fix(BODY_FORCE_Z); -NODES[2955].Fix(BODY_FORCE_X); -NODES[2955].Fix(BODY_FORCE_Y); -NODES[2955].Fix(BODY_FORCE_Z); -NODES[2956].Fix(BODY_FORCE_X); -NODES[2956].Fix(BODY_FORCE_Y); -NODES[2956].Fix(BODY_FORCE_Z); -NODES[2957].Fix(BODY_FORCE_X); -NODES[2957].Fix(BODY_FORCE_Y); -NODES[2957].Fix(BODY_FORCE_Z); -NODES[2958].Fix(BODY_FORCE_X); -NODES[2958].Fix(BODY_FORCE_Y); -NODES[2958].Fix(BODY_FORCE_Z); -NODES[2959].Fix(BODY_FORCE_X); -NODES[2959].Fix(BODY_FORCE_Y); -NODES[2959].Fix(BODY_FORCE_Z); -NODES[2960].Fix(BODY_FORCE_X); -NODES[2960].Fix(BODY_FORCE_Y); -NODES[2960].Fix(BODY_FORCE_Z); -NODES[2961].Fix(BODY_FORCE_X); -NODES[2961].Fix(BODY_FORCE_Y); -NODES[2961].Fix(BODY_FORCE_Z); -NODES[2963].Fix(BODY_FORCE_X); -NODES[2963].Fix(BODY_FORCE_Y); -NODES[2963].Fix(BODY_FORCE_Z); -NODES[2964].Fix(BODY_FORCE_X); -NODES[2964].Fix(BODY_FORCE_Y); -NODES[2964].Fix(BODY_FORCE_Z); -NODES[2965].Fix(BODY_FORCE_X); -NODES[2965].Fix(BODY_FORCE_Y); -NODES[2965].Fix(BODY_FORCE_Z); -NODES[2966].Fix(BODY_FORCE_X); -NODES[2966].Fix(BODY_FORCE_Y); -NODES[2966].Fix(BODY_FORCE_Z); -NODES[2967].Fix(BODY_FORCE_X); -NODES[2967].Fix(BODY_FORCE_Y); -NODES[2967].Fix(BODY_FORCE_Z); -NODES[2968].Fix(BODY_FORCE_X); -NODES[2968].Fix(BODY_FORCE_Y); -NODES[2968].Fix(BODY_FORCE_Z); -NODES[2969].Fix(BODY_FORCE_X); -NODES[2969].Fix(BODY_FORCE_Y); -NODES[2969].Fix(BODY_FORCE_Z); -NODES[2970].Fix(BODY_FORCE_X); -NODES[2970].Fix(BODY_FORCE_Y); -NODES[2970].Fix(BODY_FORCE_Z); -NODES[2971].Fix(BODY_FORCE_X); -NODES[2971].Fix(BODY_FORCE_Y); -NODES[2971].Fix(BODY_FORCE_Z); -NODES[2972].Fix(BODY_FORCE_X); -NODES[2972].Fix(BODY_FORCE_Y); -NODES[2972].Fix(BODY_FORCE_Z); -NODES[2973].Fix(BODY_FORCE_X); -NODES[2973].Fix(BODY_FORCE_Y); -NODES[2973].Fix(BODY_FORCE_Z); -NODES[2974].Fix(BODY_FORCE_X); -NODES[2974].Fix(BODY_FORCE_Y); -NODES[2974].Fix(BODY_FORCE_Z); -NODES[2975].Fix(BODY_FORCE_X); -NODES[2975].Fix(BODY_FORCE_Y); -NODES[2975].Fix(BODY_FORCE_Z); -NODES[2976].Fix(BODY_FORCE_X); -NODES[2976].Fix(BODY_FORCE_Y); -NODES[2976].Fix(BODY_FORCE_Z); -NODES[2977].Fix(BODY_FORCE_X); -NODES[2977].Fix(BODY_FORCE_Y); -NODES[2977].Fix(BODY_FORCE_Z); -NODES[2978].Fix(BODY_FORCE_X); -NODES[2978].Fix(BODY_FORCE_Y); -NODES[2978].Fix(BODY_FORCE_Z); -NODES[2979].Fix(BODY_FORCE_X); -NODES[2979].Fix(BODY_FORCE_Y); -NODES[2979].Fix(BODY_FORCE_Z); -NODES[2980].Fix(BODY_FORCE_X); -NODES[2980].Fix(BODY_FORCE_Y); -NODES[2980].Fix(BODY_FORCE_Z); -NODES[2981].Fix(BODY_FORCE_X); -NODES[2981].Fix(BODY_FORCE_Y); -NODES[2981].Fix(BODY_FORCE_Z); -NODES[2982].Fix(BODY_FORCE_X); -NODES[2982].Fix(BODY_FORCE_Y); -NODES[2982].Fix(BODY_FORCE_Z); -NODES[2983].Fix(BODY_FORCE_X); -NODES[2983].Fix(BODY_FORCE_Y); -NODES[2983].Fix(BODY_FORCE_Z); -NODES[2984].Fix(BODY_FORCE_X); -NODES[2984].Fix(BODY_FORCE_Y); -NODES[2984].Fix(BODY_FORCE_Z); -NODES[2985].Fix(BODY_FORCE_X); -NODES[2985].Fix(BODY_FORCE_Y); -NODES[2985].Fix(BODY_FORCE_Z); -NODES[2986].Fix(BODY_FORCE_X); -NODES[2986].Fix(BODY_FORCE_Y); -NODES[2986].Fix(BODY_FORCE_Z); -NODES[2987].Fix(BODY_FORCE_X); -NODES[2987].Fix(BODY_FORCE_Y); -NODES[2987].Fix(BODY_FORCE_Z); -NODES[2988].Fix(BODY_FORCE_X); -NODES[2988].Fix(BODY_FORCE_Y); -NODES[2988].Fix(BODY_FORCE_Z); -NODES[2989].Fix(BODY_FORCE_X); -NODES[2989].Fix(BODY_FORCE_Y); -NODES[2989].Fix(BODY_FORCE_Z); -NODES[2990].Fix(BODY_FORCE_X); -NODES[2990].Fix(BODY_FORCE_Y); -NODES[2990].Fix(BODY_FORCE_Z); -NODES[2992].Fix(BODY_FORCE_X); -NODES[2992].Fix(BODY_FORCE_Y); -NODES[2992].Fix(BODY_FORCE_Z); -NODES[2993].Fix(BODY_FORCE_X); -NODES[2993].Fix(BODY_FORCE_Y); -NODES[2993].Fix(BODY_FORCE_Z); -NODES[2994].Fix(BODY_FORCE_X); -NODES[2994].Fix(BODY_FORCE_Y); -NODES[2994].Fix(BODY_FORCE_Z); -NODES[2995].Fix(BODY_FORCE_X); -NODES[2995].Fix(BODY_FORCE_Y); -NODES[2995].Fix(BODY_FORCE_Z); -NODES[2996].Fix(BODY_FORCE_X); -NODES[2996].Fix(BODY_FORCE_Y); -NODES[2996].Fix(BODY_FORCE_Z); -NODES[2997].Fix(BODY_FORCE_X); -NODES[2997].Fix(BODY_FORCE_Y); -NODES[2997].Fix(BODY_FORCE_Z); -NODES[2998].Fix(BODY_FORCE_X); -NODES[2998].Fix(BODY_FORCE_Y); -NODES[2998].Fix(BODY_FORCE_Z); -NODES[2999].Fix(BODY_FORCE_X); -NODES[2999].Fix(BODY_FORCE_Y); -NODES[2999].Fix(BODY_FORCE_Z); -NODES[3000].Fix(BODY_FORCE_X); -NODES[3000].Fix(BODY_FORCE_Y); -NODES[3000].Fix(BODY_FORCE_Z); -NODES[3001].Fix(BODY_FORCE_X); -NODES[3001].Fix(BODY_FORCE_Y); -NODES[3001].Fix(BODY_FORCE_Z); -NODES[3002].Fix(BODY_FORCE_X); -NODES[3002].Fix(BODY_FORCE_Y); -NODES[3002].Fix(BODY_FORCE_Z); -NODES[3003].Fix(BODY_FORCE_X); -NODES[3003].Fix(BODY_FORCE_Y); -NODES[3003].Fix(BODY_FORCE_Z); -NODES[3004].Fix(BODY_FORCE_X); -NODES[3004].Fix(BODY_FORCE_Y); -NODES[3004].Fix(BODY_FORCE_Z); -NODES[3005].Fix(BODY_FORCE_X); -NODES[3005].Fix(BODY_FORCE_Y); -NODES[3005].Fix(BODY_FORCE_Z); -NODES[3006].Fix(BODY_FORCE_X); -NODES[3006].Fix(BODY_FORCE_Y); -NODES[3006].Fix(BODY_FORCE_Z); -NODES[3007].Fix(BODY_FORCE_X); -NODES[3007].Fix(BODY_FORCE_Y); -NODES[3007].Fix(BODY_FORCE_Z); -NODES[3008].Fix(BODY_FORCE_X); -NODES[3008].Fix(BODY_FORCE_Y); -NODES[3008].Fix(BODY_FORCE_Z); -NODES[3009].Fix(BODY_FORCE_X); -NODES[3009].Fix(BODY_FORCE_Y); -NODES[3009].Fix(BODY_FORCE_Z); -NODES[3010].Fix(BODY_FORCE_X); -NODES[3010].Fix(BODY_FORCE_Y); -NODES[3010].Fix(BODY_FORCE_Z); -NODES[3011].Fix(BODY_FORCE_X); -NODES[3011].Fix(BODY_FORCE_Y); -NODES[3011].Fix(BODY_FORCE_Z); -NODES[3012].Fix(BODY_FORCE_X); -NODES[3012].Fix(BODY_FORCE_Y); -NODES[3012].Fix(BODY_FORCE_Z); -NODES[3013].Fix(BODY_FORCE_X); -NODES[3013].Fix(BODY_FORCE_Y); -NODES[3013].Fix(BODY_FORCE_Z); -NODES[3014].Fix(BODY_FORCE_X); -NODES[3014].Fix(BODY_FORCE_Y); -NODES[3014].Fix(BODY_FORCE_Z); -NODES[3015].Fix(BODY_FORCE_X); -NODES[3015].Fix(BODY_FORCE_Y); -NODES[3015].Fix(BODY_FORCE_Z); -NODES[3016].Fix(BODY_FORCE_X); -NODES[3016].Fix(BODY_FORCE_Y); -NODES[3016].Fix(BODY_FORCE_Z); -NODES[3017].Fix(BODY_FORCE_X); -NODES[3017].Fix(BODY_FORCE_Y); -NODES[3017].Fix(BODY_FORCE_Z); -NODES[3018].Fix(BODY_FORCE_X); -NODES[3018].Fix(BODY_FORCE_Y); -NODES[3018].Fix(BODY_FORCE_Z); -NODES[3019].Fix(BODY_FORCE_X); -NODES[3019].Fix(BODY_FORCE_Y); -NODES[3019].Fix(BODY_FORCE_Z); -NODES[3021].Fix(BODY_FORCE_X); -NODES[3021].Fix(BODY_FORCE_Y); -NODES[3021].Fix(BODY_FORCE_Z); -NODES[3022].Fix(BODY_FORCE_X); -NODES[3022].Fix(BODY_FORCE_Y); -NODES[3022].Fix(BODY_FORCE_Z); -NODES[3023].Fix(BODY_FORCE_X); -NODES[3023].Fix(BODY_FORCE_Y); -NODES[3023].Fix(BODY_FORCE_Z); -NODES[3024].Fix(BODY_FORCE_X); -NODES[3024].Fix(BODY_FORCE_Y); -NODES[3024].Fix(BODY_FORCE_Z); -NODES[3025].Fix(BODY_FORCE_X); -NODES[3025].Fix(BODY_FORCE_Y); -NODES[3025].Fix(BODY_FORCE_Z); -NODES[3026].Fix(BODY_FORCE_X); -NODES[3026].Fix(BODY_FORCE_Y); -NODES[3026].Fix(BODY_FORCE_Z); -NODES[3027].Fix(BODY_FORCE_X); -NODES[3027].Fix(BODY_FORCE_Y); -NODES[3027].Fix(BODY_FORCE_Z); -NODES[3028].Fix(BODY_FORCE_X); -NODES[3028].Fix(BODY_FORCE_Y); -NODES[3028].Fix(BODY_FORCE_Z); -NODES[3029].Fix(BODY_FORCE_X); -NODES[3029].Fix(BODY_FORCE_Y); -NODES[3029].Fix(BODY_FORCE_Z); -NODES[3030].Fix(BODY_FORCE_X); -NODES[3030].Fix(BODY_FORCE_Y); -NODES[3030].Fix(BODY_FORCE_Z); -NODES[3031].Fix(BODY_FORCE_X); -NODES[3031].Fix(BODY_FORCE_Y); -NODES[3031].Fix(BODY_FORCE_Z); -NODES[3032].Fix(BODY_FORCE_X); -NODES[3032].Fix(BODY_FORCE_Y); -NODES[3032].Fix(BODY_FORCE_Z); -NODES[3033].Fix(BODY_FORCE_X); -NODES[3033].Fix(BODY_FORCE_Y); -NODES[3033].Fix(BODY_FORCE_Z); -NODES[3034].Fix(BODY_FORCE_X); -NODES[3034].Fix(BODY_FORCE_Y); -NODES[3034].Fix(BODY_FORCE_Z); -NODES[3035].Fix(BODY_FORCE_X); -NODES[3035].Fix(BODY_FORCE_Y); -NODES[3035].Fix(BODY_FORCE_Z); -NODES[3036].Fix(BODY_FORCE_X); -NODES[3036].Fix(BODY_FORCE_Y); -NODES[3036].Fix(BODY_FORCE_Z); -NODES[3037].Fix(BODY_FORCE_X); -NODES[3037].Fix(BODY_FORCE_Y); -NODES[3037].Fix(BODY_FORCE_Z); -NODES[3038].Fix(BODY_FORCE_X); -NODES[3038].Fix(BODY_FORCE_Y); -NODES[3038].Fix(BODY_FORCE_Z); -NODES[3039].Fix(BODY_FORCE_X); -NODES[3039].Fix(BODY_FORCE_Y); -NODES[3039].Fix(BODY_FORCE_Z); -NODES[3040].Fix(BODY_FORCE_X); -NODES[3040].Fix(BODY_FORCE_Y); -NODES[3040].Fix(BODY_FORCE_Z); -NODES[3041].Fix(BODY_FORCE_X); -NODES[3041].Fix(BODY_FORCE_Y); -NODES[3041].Fix(BODY_FORCE_Z); -NODES[3042].Fix(BODY_FORCE_X); -NODES[3042].Fix(BODY_FORCE_Y); -NODES[3042].Fix(BODY_FORCE_Z); -NODES[3043].Fix(BODY_FORCE_X); -NODES[3043].Fix(BODY_FORCE_Y); -NODES[3043].Fix(BODY_FORCE_Z); -NODES[3044].Fix(BODY_FORCE_X); -NODES[3044].Fix(BODY_FORCE_Y); -NODES[3044].Fix(BODY_FORCE_Z); -NODES[3045].Fix(BODY_FORCE_X); -NODES[3045].Fix(BODY_FORCE_Y); -NODES[3045].Fix(BODY_FORCE_Z); -NODES[3046].Fix(BODY_FORCE_X); -NODES[3046].Fix(BODY_FORCE_Y); -NODES[3046].Fix(BODY_FORCE_Z); -NODES[3047].Fix(BODY_FORCE_X); -NODES[3047].Fix(BODY_FORCE_Y); -NODES[3047].Fix(BODY_FORCE_Z); -NODES[3048].Fix(BODY_FORCE_X); -NODES[3048].Fix(BODY_FORCE_Y); -NODES[3048].Fix(BODY_FORCE_Z); -NODES[3050].Fix(BODY_FORCE_X); -NODES[3050].Fix(BODY_FORCE_Y); -NODES[3050].Fix(BODY_FORCE_Z); -NODES[3051].Fix(BODY_FORCE_X); -NODES[3051].Fix(BODY_FORCE_Y); -NODES[3051].Fix(BODY_FORCE_Z); -NODES[3052].Fix(BODY_FORCE_X); -NODES[3052].Fix(BODY_FORCE_Y); -NODES[3052].Fix(BODY_FORCE_Z); -NODES[3053].Fix(BODY_FORCE_X); -NODES[3053].Fix(BODY_FORCE_Y); -NODES[3053].Fix(BODY_FORCE_Z); -NODES[3054].Fix(BODY_FORCE_X); -NODES[3054].Fix(BODY_FORCE_Y); -NODES[3054].Fix(BODY_FORCE_Z); -NODES[3055].Fix(BODY_FORCE_X); -NODES[3055].Fix(BODY_FORCE_Y); -NODES[3055].Fix(BODY_FORCE_Z); -NODES[3056].Fix(BODY_FORCE_X); -NODES[3056].Fix(BODY_FORCE_Y); -NODES[3056].Fix(BODY_FORCE_Z); -NODES[3057].Fix(BODY_FORCE_X); -NODES[3057].Fix(BODY_FORCE_Y); -NODES[3057].Fix(BODY_FORCE_Z); -NODES[3058].Fix(BODY_FORCE_X); -NODES[3058].Fix(BODY_FORCE_Y); -NODES[3058].Fix(BODY_FORCE_Z); -NODES[3059].Fix(BODY_FORCE_X); -NODES[3059].Fix(BODY_FORCE_Y); -NODES[3059].Fix(BODY_FORCE_Z); -NODES[3060].Fix(BODY_FORCE_X); -NODES[3060].Fix(BODY_FORCE_Y); -NODES[3060].Fix(BODY_FORCE_Z); -NODES[3061].Fix(BODY_FORCE_X); -NODES[3061].Fix(BODY_FORCE_Y); -NODES[3061].Fix(BODY_FORCE_Z); -NODES[3062].Fix(BODY_FORCE_X); -NODES[3062].Fix(BODY_FORCE_Y); -NODES[3062].Fix(BODY_FORCE_Z); -NODES[3063].Fix(BODY_FORCE_X); -NODES[3063].Fix(BODY_FORCE_Y); -NODES[3063].Fix(BODY_FORCE_Z); -NODES[3064].Fix(BODY_FORCE_X); -NODES[3064].Fix(BODY_FORCE_Y); -NODES[3064].Fix(BODY_FORCE_Z); -NODES[3065].Fix(BODY_FORCE_X); -NODES[3065].Fix(BODY_FORCE_Y); -NODES[3065].Fix(BODY_FORCE_Z); -NODES[3066].Fix(BODY_FORCE_X); -NODES[3066].Fix(BODY_FORCE_Y); -NODES[3066].Fix(BODY_FORCE_Z); -NODES[3067].Fix(BODY_FORCE_X); -NODES[3067].Fix(BODY_FORCE_Y); -NODES[3067].Fix(BODY_FORCE_Z); -NODES[3068].Fix(BODY_FORCE_X); -NODES[3068].Fix(BODY_FORCE_Y); -NODES[3068].Fix(BODY_FORCE_Z); -NODES[3069].Fix(BODY_FORCE_X); -NODES[3069].Fix(BODY_FORCE_Y); -NODES[3069].Fix(BODY_FORCE_Z); -NODES[3070].Fix(BODY_FORCE_X); -NODES[3070].Fix(BODY_FORCE_Y); -NODES[3070].Fix(BODY_FORCE_Z); -NODES[3071].Fix(BODY_FORCE_X); -NODES[3071].Fix(BODY_FORCE_Y); -NODES[3071].Fix(BODY_FORCE_Z); -NODES[3072].Fix(BODY_FORCE_X); -NODES[3072].Fix(BODY_FORCE_Y); -NODES[3072].Fix(BODY_FORCE_Z); -NODES[3073].Fix(BODY_FORCE_X); -NODES[3073].Fix(BODY_FORCE_Y); -NODES[3073].Fix(BODY_FORCE_Z); -NODES[3074].Fix(BODY_FORCE_X); -NODES[3074].Fix(BODY_FORCE_Y); -NODES[3074].Fix(BODY_FORCE_Z); -NODES[3076].Fix(BODY_FORCE_X); -NODES[3076].Fix(BODY_FORCE_Y); -NODES[3076].Fix(BODY_FORCE_Z); -NODES[3077].Fix(BODY_FORCE_X); -NODES[3077].Fix(BODY_FORCE_Y); -NODES[3077].Fix(BODY_FORCE_Z); -NODES[3078].Fix(BODY_FORCE_X); -NODES[3078].Fix(BODY_FORCE_Y); -NODES[3078].Fix(BODY_FORCE_Z); -NODES[3079].Fix(BODY_FORCE_X); -NODES[3079].Fix(BODY_FORCE_Y); -NODES[3079].Fix(BODY_FORCE_Z); -NODES[3080].Fix(BODY_FORCE_X); -NODES[3080].Fix(BODY_FORCE_Y); -NODES[3080].Fix(BODY_FORCE_Z); -NODES[3081].Fix(BODY_FORCE_X); -NODES[3081].Fix(BODY_FORCE_Y); -NODES[3081].Fix(BODY_FORCE_Z); -NODES[3082].Fix(BODY_FORCE_X); -NODES[3082].Fix(BODY_FORCE_Y); -NODES[3082].Fix(BODY_FORCE_Z); -NODES[3083].Fix(BODY_FORCE_X); -NODES[3083].Fix(BODY_FORCE_Y); -NODES[3083].Fix(BODY_FORCE_Z); -NODES[3084].Fix(BODY_FORCE_X); -NODES[3084].Fix(BODY_FORCE_Y); -NODES[3084].Fix(BODY_FORCE_Z); -NODES[3085].Fix(BODY_FORCE_X); -NODES[3085].Fix(BODY_FORCE_Y); -NODES[3085].Fix(BODY_FORCE_Z); -NODES[3086].Fix(BODY_FORCE_X); -NODES[3086].Fix(BODY_FORCE_Y); -NODES[3086].Fix(BODY_FORCE_Z); -NODES[3087].Fix(BODY_FORCE_X); -NODES[3087].Fix(BODY_FORCE_Y); -NODES[3087].Fix(BODY_FORCE_Z); -NODES[3088].Fix(BODY_FORCE_X); -NODES[3088].Fix(BODY_FORCE_Y); -NODES[3088].Fix(BODY_FORCE_Z); -NODES[3089].Fix(BODY_FORCE_X); -NODES[3089].Fix(BODY_FORCE_Y); -NODES[3089].Fix(BODY_FORCE_Z); -NODES[3090].Fix(BODY_FORCE_X); -NODES[3090].Fix(BODY_FORCE_Y); -NODES[3090].Fix(BODY_FORCE_Z); -NODES[3091].Fix(BODY_FORCE_X); -NODES[3091].Fix(BODY_FORCE_Y); -NODES[3091].Fix(BODY_FORCE_Z); -NODES[3092].Fix(BODY_FORCE_X); -NODES[3092].Fix(BODY_FORCE_Y); -NODES[3092].Fix(BODY_FORCE_Z); -NODES[3093].Fix(BODY_FORCE_X); -NODES[3093].Fix(BODY_FORCE_Y); -NODES[3093].Fix(BODY_FORCE_Z); -NODES[3094].Fix(BODY_FORCE_X); -NODES[3094].Fix(BODY_FORCE_Y); -NODES[3094].Fix(BODY_FORCE_Z); -NODES[3095].Fix(BODY_FORCE_X); -NODES[3095].Fix(BODY_FORCE_Y); -NODES[3095].Fix(BODY_FORCE_Z); -NODES[3096].Fix(BODY_FORCE_X); -NODES[3096].Fix(BODY_FORCE_Y); -NODES[3096].Fix(BODY_FORCE_Z); -NODES[3097].Fix(BODY_FORCE_X); -NODES[3097].Fix(BODY_FORCE_Y); -NODES[3097].Fix(BODY_FORCE_Z); -NODES[3098].Fix(BODY_FORCE_X); -NODES[3098].Fix(BODY_FORCE_Y); -NODES[3098].Fix(BODY_FORCE_Z); -NODES[3099].Fix(BODY_FORCE_X); -NODES[3099].Fix(BODY_FORCE_Y); -NODES[3099].Fix(BODY_FORCE_Z); -NODES[3100].Fix(BODY_FORCE_X); -NODES[3100].Fix(BODY_FORCE_Y); -NODES[3100].Fix(BODY_FORCE_Z); -NODES[3101].Fix(BODY_FORCE_X); -NODES[3101].Fix(BODY_FORCE_Y); -NODES[3101].Fix(BODY_FORCE_Z); -NODES[3103].Fix(BODY_FORCE_X); -NODES[3103].Fix(BODY_FORCE_Y); -NODES[3103].Fix(BODY_FORCE_Z); -NODES[3104].Fix(BODY_FORCE_X); -NODES[3104].Fix(BODY_FORCE_Y); -NODES[3104].Fix(BODY_FORCE_Z); -NODES[3105].Fix(BODY_FORCE_X); -NODES[3105].Fix(BODY_FORCE_Y); -NODES[3105].Fix(BODY_FORCE_Z); -NODES[3106].Fix(BODY_FORCE_X); -NODES[3106].Fix(BODY_FORCE_Y); -NODES[3106].Fix(BODY_FORCE_Z); -NODES[3107].Fix(BODY_FORCE_X); -NODES[3107].Fix(BODY_FORCE_Y); -NODES[3107].Fix(BODY_FORCE_Z); -NODES[3108].Fix(BODY_FORCE_X); -NODES[3108].Fix(BODY_FORCE_Y); -NODES[3108].Fix(BODY_FORCE_Z); -NODES[3109].Fix(BODY_FORCE_X); -NODES[3109].Fix(BODY_FORCE_Y); -NODES[3109].Fix(BODY_FORCE_Z); -NODES[3110].Fix(BODY_FORCE_X); -NODES[3110].Fix(BODY_FORCE_Y); -NODES[3110].Fix(BODY_FORCE_Z); -NODES[3111].Fix(BODY_FORCE_X); -NODES[3111].Fix(BODY_FORCE_Y); -NODES[3111].Fix(BODY_FORCE_Z); -NODES[3112].Fix(BODY_FORCE_X); -NODES[3112].Fix(BODY_FORCE_Y); -NODES[3112].Fix(BODY_FORCE_Z); -NODES[3113].Fix(BODY_FORCE_X); -NODES[3113].Fix(BODY_FORCE_Y); -NODES[3113].Fix(BODY_FORCE_Z); -NODES[3114].Fix(BODY_FORCE_X); -NODES[3114].Fix(BODY_FORCE_Y); -NODES[3114].Fix(BODY_FORCE_Z); -NODES[3115].Fix(BODY_FORCE_X); -NODES[3115].Fix(BODY_FORCE_Y); -NODES[3115].Fix(BODY_FORCE_Z); -NODES[3116].Fix(BODY_FORCE_X); -NODES[3116].Fix(BODY_FORCE_Y); -NODES[3116].Fix(BODY_FORCE_Z); -NODES[3117].Fix(BODY_FORCE_X); -NODES[3117].Fix(BODY_FORCE_Y); -NODES[3117].Fix(BODY_FORCE_Z); -NODES[3118].Fix(BODY_FORCE_X); -NODES[3118].Fix(BODY_FORCE_Y); -NODES[3118].Fix(BODY_FORCE_Z); -NODES[3119].Fix(BODY_FORCE_X); -NODES[3119].Fix(BODY_FORCE_Y); -NODES[3119].Fix(BODY_FORCE_Z); -NODES[3120].Fix(BODY_FORCE_X); -NODES[3120].Fix(BODY_FORCE_Y); -NODES[3120].Fix(BODY_FORCE_Z); -NODES[3121].Fix(BODY_FORCE_X); -NODES[3121].Fix(BODY_FORCE_Y); -NODES[3121].Fix(BODY_FORCE_Z); -NODES[3122].Fix(BODY_FORCE_X); -NODES[3122].Fix(BODY_FORCE_Y); -NODES[3122].Fix(BODY_FORCE_Z); -NODES[3123].Fix(BODY_FORCE_X); -NODES[3123].Fix(BODY_FORCE_Y); -NODES[3123].Fix(BODY_FORCE_Z); -NODES[3124].Fix(BODY_FORCE_X); -NODES[3124].Fix(BODY_FORCE_Y); -NODES[3124].Fix(BODY_FORCE_Z); -NODES[3125].Fix(BODY_FORCE_X); -NODES[3125].Fix(BODY_FORCE_Y); -NODES[3125].Fix(BODY_FORCE_Z); -NODES[3126].Fix(BODY_FORCE_X); -NODES[3126].Fix(BODY_FORCE_Y); -NODES[3126].Fix(BODY_FORCE_Z); -NODES[3127].Fix(BODY_FORCE_X); -NODES[3127].Fix(BODY_FORCE_Y); -NODES[3127].Fix(BODY_FORCE_Z); -NODES[3128].Fix(BODY_FORCE_X); -NODES[3128].Fix(BODY_FORCE_Y); -NODES[3128].Fix(BODY_FORCE_Z); -NODES[3129].Fix(BODY_FORCE_X); -NODES[3129].Fix(BODY_FORCE_Y); -NODES[3129].Fix(BODY_FORCE_Z); -NODES[3130].Fix(BODY_FORCE_X); -NODES[3130].Fix(BODY_FORCE_Y); -NODES[3130].Fix(BODY_FORCE_Z); -NODES[3132].Fix(BODY_FORCE_X); -NODES[3132].Fix(BODY_FORCE_Y); -NODES[3132].Fix(BODY_FORCE_Z); -NODES[3133].Fix(BODY_FORCE_X); -NODES[3133].Fix(BODY_FORCE_Y); -NODES[3133].Fix(BODY_FORCE_Z); -NODES[3134].Fix(BODY_FORCE_X); -NODES[3134].Fix(BODY_FORCE_Y); -NODES[3134].Fix(BODY_FORCE_Z); -NODES[3135].Fix(BODY_FORCE_X); -NODES[3135].Fix(BODY_FORCE_Y); -NODES[3135].Fix(BODY_FORCE_Z); -NODES[3136].Fix(BODY_FORCE_X); -NODES[3136].Fix(BODY_FORCE_Y); -NODES[3136].Fix(BODY_FORCE_Z); -NODES[3137].Fix(BODY_FORCE_X); -NODES[3137].Fix(BODY_FORCE_Y); -NODES[3137].Fix(BODY_FORCE_Z); -NODES[3138].Fix(BODY_FORCE_X); -NODES[3138].Fix(BODY_FORCE_Y); -NODES[3138].Fix(BODY_FORCE_Z); -NODES[3139].Fix(BODY_FORCE_X); -NODES[3139].Fix(BODY_FORCE_Y); -NODES[3139].Fix(BODY_FORCE_Z); -NODES[3140].Fix(BODY_FORCE_X); -NODES[3140].Fix(BODY_FORCE_Y); -NODES[3140].Fix(BODY_FORCE_Z); -NODES[3141].Fix(BODY_FORCE_X); -NODES[3141].Fix(BODY_FORCE_Y); -NODES[3141].Fix(BODY_FORCE_Z); -NODES[3142].Fix(BODY_FORCE_X); -NODES[3142].Fix(BODY_FORCE_Y); -NODES[3142].Fix(BODY_FORCE_Z); -NODES[3143].Fix(BODY_FORCE_X); -NODES[3143].Fix(BODY_FORCE_Y); -NODES[3143].Fix(BODY_FORCE_Z); -NODES[3144].Fix(BODY_FORCE_X); -NODES[3144].Fix(BODY_FORCE_Y); -NODES[3144].Fix(BODY_FORCE_Z); -NODES[3145].Fix(BODY_FORCE_X); -NODES[3145].Fix(BODY_FORCE_Y); -NODES[3145].Fix(BODY_FORCE_Z); -NODES[3146].Fix(BODY_FORCE_X); -NODES[3146].Fix(BODY_FORCE_Y); -NODES[3146].Fix(BODY_FORCE_Z); -NODES[3147].Fix(BODY_FORCE_X); -NODES[3147].Fix(BODY_FORCE_Y); -NODES[3147].Fix(BODY_FORCE_Z); -NODES[3148].Fix(BODY_FORCE_X); -NODES[3148].Fix(BODY_FORCE_Y); -NODES[3148].Fix(BODY_FORCE_Z); -NODES[3149].Fix(BODY_FORCE_X); -NODES[3149].Fix(BODY_FORCE_Y); -NODES[3149].Fix(BODY_FORCE_Z); -NODES[3150].Fix(BODY_FORCE_X); -NODES[3150].Fix(BODY_FORCE_Y); -NODES[3150].Fix(BODY_FORCE_Z); -NODES[3151].Fix(BODY_FORCE_X); -NODES[3151].Fix(BODY_FORCE_Y); -NODES[3151].Fix(BODY_FORCE_Z); -NODES[3152].Fix(BODY_FORCE_X); -NODES[3152].Fix(BODY_FORCE_Y); -NODES[3152].Fix(BODY_FORCE_Z); -NODES[3153].Fix(BODY_FORCE_X); -NODES[3153].Fix(BODY_FORCE_Y); -NODES[3153].Fix(BODY_FORCE_Z); -NODES[3154].Fix(BODY_FORCE_X); -NODES[3154].Fix(BODY_FORCE_Y); -NODES[3154].Fix(BODY_FORCE_Z); -NODES[3155].Fix(BODY_FORCE_X); -NODES[3155].Fix(BODY_FORCE_Y); -NODES[3155].Fix(BODY_FORCE_Z); -NODES[3156].Fix(BODY_FORCE_X); -NODES[3156].Fix(BODY_FORCE_Y); -NODES[3156].Fix(BODY_FORCE_Z); -NODES[3157].Fix(BODY_FORCE_X); -NODES[3157].Fix(BODY_FORCE_Y); -NODES[3157].Fix(BODY_FORCE_Z); -NODES[3158].Fix(BODY_FORCE_X); -NODES[3158].Fix(BODY_FORCE_Y); -NODES[3158].Fix(BODY_FORCE_Z); -NODES[3159].Fix(BODY_FORCE_X); -NODES[3159].Fix(BODY_FORCE_Y); -NODES[3159].Fix(BODY_FORCE_Z); -NODES[3160].Fix(BODY_FORCE_X); -NODES[3160].Fix(BODY_FORCE_Y); -NODES[3160].Fix(BODY_FORCE_Z); -NODES[3162].Fix(BODY_FORCE_X); -NODES[3162].Fix(BODY_FORCE_Y); -NODES[3162].Fix(BODY_FORCE_Z); -NODES[3163].Fix(BODY_FORCE_X); -NODES[3163].Fix(BODY_FORCE_Y); -NODES[3163].Fix(BODY_FORCE_Z); -NODES[3164].Fix(BODY_FORCE_X); -NODES[3164].Fix(BODY_FORCE_Y); -NODES[3164].Fix(BODY_FORCE_Z); -NODES[3165].Fix(BODY_FORCE_X); -NODES[3165].Fix(BODY_FORCE_Y); -NODES[3165].Fix(BODY_FORCE_Z); -NODES[3166].Fix(BODY_FORCE_X); -NODES[3166].Fix(BODY_FORCE_Y); -NODES[3166].Fix(BODY_FORCE_Z); -NODES[3167].Fix(BODY_FORCE_X); -NODES[3167].Fix(BODY_FORCE_Y); -NODES[3167].Fix(BODY_FORCE_Z); -NODES[3168].Fix(BODY_FORCE_X); -NODES[3168].Fix(BODY_FORCE_Y); -NODES[3168].Fix(BODY_FORCE_Z); -NODES[3169].Fix(BODY_FORCE_X); -NODES[3169].Fix(BODY_FORCE_Y); -NODES[3169].Fix(BODY_FORCE_Z); -NODES[3170].Fix(BODY_FORCE_X); -NODES[3170].Fix(BODY_FORCE_Y); -NODES[3170].Fix(BODY_FORCE_Z); -NODES[3171].Fix(BODY_FORCE_X); -NODES[3171].Fix(BODY_FORCE_Y); -NODES[3171].Fix(BODY_FORCE_Z); -NODES[3172].Fix(BODY_FORCE_X); -NODES[3172].Fix(BODY_FORCE_Y); -NODES[3172].Fix(BODY_FORCE_Z); -NODES[3173].Fix(BODY_FORCE_X); -NODES[3173].Fix(BODY_FORCE_Y); -NODES[3173].Fix(BODY_FORCE_Z); -NODES[3174].Fix(BODY_FORCE_X); -NODES[3174].Fix(BODY_FORCE_Y); -NODES[3174].Fix(BODY_FORCE_Z); -NODES[3175].Fix(BODY_FORCE_X); -NODES[3175].Fix(BODY_FORCE_Y); -NODES[3175].Fix(BODY_FORCE_Z); -NODES[3176].Fix(BODY_FORCE_X); -NODES[3176].Fix(BODY_FORCE_Y); -NODES[3176].Fix(BODY_FORCE_Z); -NODES[3177].Fix(BODY_FORCE_X); -NODES[3177].Fix(BODY_FORCE_Y); -NODES[3177].Fix(BODY_FORCE_Z); -NODES[3178].Fix(BODY_FORCE_X); -NODES[3178].Fix(BODY_FORCE_Y); -NODES[3178].Fix(BODY_FORCE_Z); -NODES[3179].Fix(BODY_FORCE_X); -NODES[3179].Fix(BODY_FORCE_Y); -NODES[3179].Fix(BODY_FORCE_Z); -NODES[3180].Fix(BODY_FORCE_X); -NODES[3180].Fix(BODY_FORCE_Y); -NODES[3180].Fix(BODY_FORCE_Z); -NODES[3181].Fix(BODY_FORCE_X); -NODES[3181].Fix(BODY_FORCE_Y); -NODES[3181].Fix(BODY_FORCE_Z); -NODES[3182].Fix(BODY_FORCE_X); -NODES[3182].Fix(BODY_FORCE_Y); -NODES[3182].Fix(BODY_FORCE_Z); -NODES[3183].Fix(BODY_FORCE_X); -NODES[3183].Fix(BODY_FORCE_Y); -NODES[3183].Fix(BODY_FORCE_Z); -NODES[3184].Fix(BODY_FORCE_X); -NODES[3184].Fix(BODY_FORCE_Y); -NODES[3184].Fix(BODY_FORCE_Z); -NODES[3185].Fix(BODY_FORCE_X); -NODES[3185].Fix(BODY_FORCE_Y); -NODES[3185].Fix(BODY_FORCE_Z); -NODES[3186].Fix(BODY_FORCE_X); -NODES[3186].Fix(BODY_FORCE_Y); -NODES[3186].Fix(BODY_FORCE_Z); -NODES[3187].Fix(BODY_FORCE_X); -NODES[3187].Fix(BODY_FORCE_Y); -NODES[3187].Fix(BODY_FORCE_Z); -NODES[3189].Fix(BODY_FORCE_X); -NODES[3189].Fix(BODY_FORCE_Y); -NODES[3189].Fix(BODY_FORCE_Z); -NODES[3190].Fix(BODY_FORCE_X); -NODES[3190].Fix(BODY_FORCE_Y); -NODES[3190].Fix(BODY_FORCE_Z); -NODES[3191].Fix(BODY_FORCE_X); -NODES[3191].Fix(BODY_FORCE_Y); -NODES[3191].Fix(BODY_FORCE_Z); -NODES[3192].Fix(BODY_FORCE_X); -NODES[3192].Fix(BODY_FORCE_Y); -NODES[3192].Fix(BODY_FORCE_Z); -NODES[3193].Fix(BODY_FORCE_X); -NODES[3193].Fix(BODY_FORCE_Y); -NODES[3193].Fix(BODY_FORCE_Z); -NODES[3194].Fix(BODY_FORCE_X); -NODES[3194].Fix(BODY_FORCE_Y); -NODES[3194].Fix(BODY_FORCE_Z); -NODES[3195].Fix(BODY_FORCE_X); -NODES[3195].Fix(BODY_FORCE_Y); -NODES[3195].Fix(BODY_FORCE_Z); -NODES[3196].Fix(BODY_FORCE_X); -NODES[3196].Fix(BODY_FORCE_Y); -NODES[3196].Fix(BODY_FORCE_Z); -NODES[3197].Fix(BODY_FORCE_X); -NODES[3197].Fix(BODY_FORCE_Y); -NODES[3197].Fix(BODY_FORCE_Z); -NODES[3198].Fix(BODY_FORCE_X); -NODES[3198].Fix(BODY_FORCE_Y); -NODES[3198].Fix(BODY_FORCE_Z); -NODES[3199].Fix(BODY_FORCE_X); -NODES[3199].Fix(BODY_FORCE_Y); -NODES[3199].Fix(BODY_FORCE_Z); -NODES[3200].Fix(BODY_FORCE_X); -NODES[3200].Fix(BODY_FORCE_Y); -NODES[3200].Fix(BODY_FORCE_Z); -NODES[3201].Fix(BODY_FORCE_X); -NODES[3201].Fix(BODY_FORCE_Y); -NODES[3201].Fix(BODY_FORCE_Z); -NODES[3202].Fix(BODY_FORCE_X); -NODES[3202].Fix(BODY_FORCE_Y); -NODES[3202].Fix(BODY_FORCE_Z); -NODES[3203].Fix(BODY_FORCE_X); -NODES[3203].Fix(BODY_FORCE_Y); -NODES[3203].Fix(BODY_FORCE_Z); -NODES[3204].Fix(BODY_FORCE_X); -NODES[3204].Fix(BODY_FORCE_Y); -NODES[3204].Fix(BODY_FORCE_Z); -NODES[3205].Fix(BODY_FORCE_X); -NODES[3205].Fix(BODY_FORCE_Y); -NODES[3205].Fix(BODY_FORCE_Z); -NODES[3206].Fix(BODY_FORCE_X); -NODES[3206].Fix(BODY_FORCE_Y); -NODES[3206].Fix(BODY_FORCE_Z); -NODES[3207].Fix(BODY_FORCE_X); -NODES[3207].Fix(BODY_FORCE_Y); -NODES[3207].Fix(BODY_FORCE_Z); -NODES[3208].Fix(BODY_FORCE_X); -NODES[3208].Fix(BODY_FORCE_Y); -NODES[3208].Fix(BODY_FORCE_Z); -NODES[3209].Fix(BODY_FORCE_X); -NODES[3209].Fix(BODY_FORCE_Y); -NODES[3209].Fix(BODY_FORCE_Z); -NODES[3210].Fix(BODY_FORCE_X); -NODES[3210].Fix(BODY_FORCE_Y); -NODES[3210].Fix(BODY_FORCE_Z); -NODES[3211].Fix(BODY_FORCE_X); -NODES[3211].Fix(BODY_FORCE_Y); -NODES[3211].Fix(BODY_FORCE_Z); -NODES[3212].Fix(BODY_FORCE_X); -NODES[3212].Fix(BODY_FORCE_Y); -NODES[3212].Fix(BODY_FORCE_Z); -NODES[3213].Fix(BODY_FORCE_X); -NODES[3213].Fix(BODY_FORCE_Y); -NODES[3213].Fix(BODY_FORCE_Z); -NODES[3214].Fix(BODY_FORCE_X); -NODES[3214].Fix(BODY_FORCE_Y); -NODES[3214].Fix(BODY_FORCE_Z); -NODES[3216].Fix(BODY_FORCE_X); -NODES[3216].Fix(BODY_FORCE_Y); -NODES[3216].Fix(BODY_FORCE_Z); -NODES[3217].Fix(BODY_FORCE_X); -NODES[3217].Fix(BODY_FORCE_Y); -NODES[3217].Fix(BODY_FORCE_Z); -NODES[3218].Fix(BODY_FORCE_X); -NODES[3218].Fix(BODY_FORCE_Y); -NODES[3218].Fix(BODY_FORCE_Z); -NODES[3219].Fix(BODY_FORCE_X); -NODES[3219].Fix(BODY_FORCE_Y); -NODES[3219].Fix(BODY_FORCE_Z); -NODES[3220].Fix(BODY_FORCE_X); -NODES[3220].Fix(BODY_FORCE_Y); -NODES[3220].Fix(BODY_FORCE_Z); -NODES[3221].Fix(BODY_FORCE_X); -NODES[3221].Fix(BODY_FORCE_Y); -NODES[3221].Fix(BODY_FORCE_Z); -NODES[3222].Fix(BODY_FORCE_X); -NODES[3222].Fix(BODY_FORCE_Y); -NODES[3222].Fix(BODY_FORCE_Z); -NODES[3223].Fix(BODY_FORCE_X); -NODES[3223].Fix(BODY_FORCE_Y); -NODES[3223].Fix(BODY_FORCE_Z); -NODES[3224].Fix(BODY_FORCE_X); -NODES[3224].Fix(BODY_FORCE_Y); -NODES[3224].Fix(BODY_FORCE_Z); -NODES[3225].Fix(BODY_FORCE_X); -NODES[3225].Fix(BODY_FORCE_Y); -NODES[3225].Fix(BODY_FORCE_Z); -NODES[3226].Fix(BODY_FORCE_X); -NODES[3226].Fix(BODY_FORCE_Y); -NODES[3226].Fix(BODY_FORCE_Z); -NODES[3227].Fix(BODY_FORCE_X); -NODES[3227].Fix(BODY_FORCE_Y); -NODES[3227].Fix(BODY_FORCE_Z); -NODES[3228].Fix(BODY_FORCE_X); -NODES[3228].Fix(BODY_FORCE_Y); -NODES[3228].Fix(BODY_FORCE_Z); -NODES[3229].Fix(BODY_FORCE_X); -NODES[3229].Fix(BODY_FORCE_Y); -NODES[3229].Fix(BODY_FORCE_Z); -NODES[3230].Fix(BODY_FORCE_X); -NODES[3230].Fix(BODY_FORCE_Y); -NODES[3230].Fix(BODY_FORCE_Z); -NODES[3231].Fix(BODY_FORCE_X); -NODES[3231].Fix(BODY_FORCE_Y); -NODES[3231].Fix(BODY_FORCE_Z); -NODES[3232].Fix(BODY_FORCE_X); -NODES[3232].Fix(BODY_FORCE_Y); -NODES[3232].Fix(BODY_FORCE_Z); -NODES[3233].Fix(BODY_FORCE_X); -NODES[3233].Fix(BODY_FORCE_Y); -NODES[3233].Fix(BODY_FORCE_Z); -NODES[3234].Fix(BODY_FORCE_X); -NODES[3234].Fix(BODY_FORCE_Y); -NODES[3234].Fix(BODY_FORCE_Z); -NODES[3235].Fix(BODY_FORCE_X); -NODES[3235].Fix(BODY_FORCE_Y); -NODES[3235].Fix(BODY_FORCE_Z); -NODES[3236].Fix(BODY_FORCE_X); -NODES[3236].Fix(BODY_FORCE_Y); -NODES[3236].Fix(BODY_FORCE_Z); -NODES[3237].Fix(BODY_FORCE_X); -NODES[3237].Fix(BODY_FORCE_Y); -NODES[3237].Fix(BODY_FORCE_Z); -NODES[3238].Fix(BODY_FORCE_X); -NODES[3238].Fix(BODY_FORCE_Y); -NODES[3238].Fix(BODY_FORCE_Z); -NODES[3239].Fix(BODY_FORCE_X); -NODES[3239].Fix(BODY_FORCE_Y); -NODES[3239].Fix(BODY_FORCE_Z); -NODES[3240].Fix(BODY_FORCE_X); -NODES[3240].Fix(BODY_FORCE_Y); -NODES[3240].Fix(BODY_FORCE_Z); -NODES[3241].Fix(BODY_FORCE_X); -NODES[3241].Fix(BODY_FORCE_Y); -NODES[3241].Fix(BODY_FORCE_Z); -NODES[3243].Fix(BODY_FORCE_X); -NODES[3243].Fix(BODY_FORCE_Y); -NODES[3243].Fix(BODY_FORCE_Z); -NODES[3244].Fix(BODY_FORCE_X); -NODES[3244].Fix(BODY_FORCE_Y); -NODES[3244].Fix(BODY_FORCE_Z); -NODES[3245].Fix(BODY_FORCE_X); -NODES[3245].Fix(BODY_FORCE_Y); -NODES[3245].Fix(BODY_FORCE_Z); -NODES[3246].Fix(BODY_FORCE_X); -NODES[3246].Fix(BODY_FORCE_Y); -NODES[3246].Fix(BODY_FORCE_Z); -NODES[3247].Fix(BODY_FORCE_X); -NODES[3247].Fix(BODY_FORCE_Y); -NODES[3247].Fix(BODY_FORCE_Z); -NODES[3248].Fix(BODY_FORCE_X); -NODES[3248].Fix(BODY_FORCE_Y); -NODES[3248].Fix(BODY_FORCE_Z); -NODES[3249].Fix(BODY_FORCE_X); -NODES[3249].Fix(BODY_FORCE_Y); -NODES[3249].Fix(BODY_FORCE_Z); -NODES[3250].Fix(BODY_FORCE_X); -NODES[3250].Fix(BODY_FORCE_Y); -NODES[3250].Fix(BODY_FORCE_Z); -NODES[3251].Fix(BODY_FORCE_X); -NODES[3251].Fix(BODY_FORCE_Y); -NODES[3251].Fix(BODY_FORCE_Z); -NODES[3252].Fix(BODY_FORCE_X); -NODES[3252].Fix(BODY_FORCE_Y); -NODES[3252].Fix(BODY_FORCE_Z); -NODES[3253].Fix(BODY_FORCE_X); -NODES[3253].Fix(BODY_FORCE_Y); -NODES[3253].Fix(BODY_FORCE_Z); -NODES[3254].Fix(BODY_FORCE_X); -NODES[3254].Fix(BODY_FORCE_Y); -NODES[3254].Fix(BODY_FORCE_Z); -NODES[3255].Fix(BODY_FORCE_X); -NODES[3255].Fix(BODY_FORCE_Y); -NODES[3255].Fix(BODY_FORCE_Z); -NODES[3256].Fix(BODY_FORCE_X); -NODES[3256].Fix(BODY_FORCE_Y); -NODES[3256].Fix(BODY_FORCE_Z); -NODES[3257].Fix(BODY_FORCE_X); -NODES[3257].Fix(BODY_FORCE_Y); -NODES[3257].Fix(BODY_FORCE_Z); -NODES[3258].Fix(BODY_FORCE_X); -NODES[3258].Fix(BODY_FORCE_Y); -NODES[3258].Fix(BODY_FORCE_Z); -NODES[3259].Fix(BODY_FORCE_X); -NODES[3259].Fix(BODY_FORCE_Y); -NODES[3259].Fix(BODY_FORCE_Z); -NODES[3260].Fix(BODY_FORCE_X); -NODES[3260].Fix(BODY_FORCE_Y); -NODES[3260].Fix(BODY_FORCE_Z); -NODES[3261].Fix(BODY_FORCE_X); -NODES[3261].Fix(BODY_FORCE_Y); -NODES[3261].Fix(BODY_FORCE_Z); -NODES[3262].Fix(BODY_FORCE_X); -NODES[3262].Fix(BODY_FORCE_Y); -NODES[3262].Fix(BODY_FORCE_Z); -NODES[3263].Fix(BODY_FORCE_X); -NODES[3263].Fix(BODY_FORCE_Y); -NODES[3263].Fix(BODY_FORCE_Z); -NODES[3264].Fix(BODY_FORCE_X); -NODES[3264].Fix(BODY_FORCE_Y); -NODES[3264].Fix(BODY_FORCE_Z); -NODES[3265].Fix(BODY_FORCE_X); -NODES[3265].Fix(BODY_FORCE_Y); -NODES[3265].Fix(BODY_FORCE_Z); -NODES[3266].Fix(BODY_FORCE_X); -NODES[3266].Fix(BODY_FORCE_Y); -NODES[3266].Fix(BODY_FORCE_Z); -NODES[3268].Fix(BODY_FORCE_X); -NODES[3268].Fix(BODY_FORCE_Y); -NODES[3268].Fix(BODY_FORCE_Z); -NODES[3269].Fix(BODY_FORCE_X); -NODES[3269].Fix(BODY_FORCE_Y); -NODES[3269].Fix(BODY_FORCE_Z); -NODES[3270].Fix(BODY_FORCE_X); -NODES[3270].Fix(BODY_FORCE_Y); -NODES[3270].Fix(BODY_FORCE_Z); -NODES[3271].Fix(BODY_FORCE_X); -NODES[3271].Fix(BODY_FORCE_Y); -NODES[3271].Fix(BODY_FORCE_Z); -NODES[3272].Fix(BODY_FORCE_X); -NODES[3272].Fix(BODY_FORCE_Y); -NODES[3272].Fix(BODY_FORCE_Z); -NODES[3273].Fix(BODY_FORCE_X); -NODES[3273].Fix(BODY_FORCE_Y); -NODES[3273].Fix(BODY_FORCE_Z); -NODES[3274].Fix(BODY_FORCE_X); -NODES[3274].Fix(BODY_FORCE_Y); -NODES[3274].Fix(BODY_FORCE_Z); -NODES[3275].Fix(BODY_FORCE_X); -NODES[3275].Fix(BODY_FORCE_Y); -NODES[3275].Fix(BODY_FORCE_Z); -NODES[3276].Fix(BODY_FORCE_X); -NODES[3276].Fix(BODY_FORCE_Y); -NODES[3276].Fix(BODY_FORCE_Z); -NODES[3277].Fix(BODY_FORCE_X); -NODES[3277].Fix(BODY_FORCE_Y); -NODES[3277].Fix(BODY_FORCE_Z); -NODES[3278].Fix(BODY_FORCE_X); -NODES[3278].Fix(BODY_FORCE_Y); -NODES[3278].Fix(BODY_FORCE_Z); -NODES[3279].Fix(BODY_FORCE_X); -NODES[3279].Fix(BODY_FORCE_Y); -NODES[3279].Fix(BODY_FORCE_Z); -NODES[3280].Fix(BODY_FORCE_X); -NODES[3280].Fix(BODY_FORCE_Y); -NODES[3280].Fix(BODY_FORCE_Z); -NODES[3281].Fix(BODY_FORCE_X); -NODES[3281].Fix(BODY_FORCE_Y); -NODES[3281].Fix(BODY_FORCE_Z); -NODES[3282].Fix(BODY_FORCE_X); -NODES[3282].Fix(BODY_FORCE_Y); -NODES[3282].Fix(BODY_FORCE_Z); -NODES[3283].Fix(BODY_FORCE_X); -NODES[3283].Fix(BODY_FORCE_Y); -NODES[3283].Fix(BODY_FORCE_Z); -NODES[3284].Fix(BODY_FORCE_X); -NODES[3284].Fix(BODY_FORCE_Y); -NODES[3284].Fix(BODY_FORCE_Z); -NODES[3285].Fix(BODY_FORCE_X); -NODES[3285].Fix(BODY_FORCE_Y); -NODES[3285].Fix(BODY_FORCE_Z); -NODES[3286].Fix(BODY_FORCE_X); -NODES[3286].Fix(BODY_FORCE_Y); -NODES[3286].Fix(BODY_FORCE_Z); -NODES[3287].Fix(BODY_FORCE_X); -NODES[3287].Fix(BODY_FORCE_Y); -NODES[3287].Fix(BODY_FORCE_Z); -NODES[3288].Fix(BODY_FORCE_X); -NODES[3288].Fix(BODY_FORCE_Y); -NODES[3288].Fix(BODY_FORCE_Z); -NODES[3289].Fix(BODY_FORCE_X); -NODES[3289].Fix(BODY_FORCE_Y); -NODES[3289].Fix(BODY_FORCE_Z); -NODES[3290].Fix(BODY_FORCE_X); -NODES[3290].Fix(BODY_FORCE_Y); -NODES[3290].Fix(BODY_FORCE_Z); -NODES[3291].Fix(BODY_FORCE_X); -NODES[3291].Fix(BODY_FORCE_Y); -NODES[3291].Fix(BODY_FORCE_Z); -NODES[3293].Fix(BODY_FORCE_X); -NODES[3293].Fix(BODY_FORCE_Y); -NODES[3293].Fix(BODY_FORCE_Z); -NODES[3294].Fix(BODY_FORCE_X); -NODES[3294].Fix(BODY_FORCE_Y); -NODES[3294].Fix(BODY_FORCE_Z); -NODES[3295].Fix(BODY_FORCE_X); -NODES[3295].Fix(BODY_FORCE_Y); -NODES[3295].Fix(BODY_FORCE_Z); -NODES[3296].Fix(BODY_FORCE_X); -NODES[3296].Fix(BODY_FORCE_Y); -NODES[3296].Fix(BODY_FORCE_Z); -NODES[3297].Fix(BODY_FORCE_X); -NODES[3297].Fix(BODY_FORCE_Y); -NODES[3297].Fix(BODY_FORCE_Z); -NODES[3298].Fix(BODY_FORCE_X); -NODES[3298].Fix(BODY_FORCE_Y); -NODES[3298].Fix(BODY_FORCE_Z); -NODES[3299].Fix(BODY_FORCE_X); -NODES[3299].Fix(BODY_FORCE_Y); -NODES[3299].Fix(BODY_FORCE_Z); -NODES[3300].Fix(BODY_FORCE_X); -NODES[3300].Fix(BODY_FORCE_Y); -NODES[3300].Fix(BODY_FORCE_Z); -NODES[3301].Fix(BODY_FORCE_X); -NODES[3301].Fix(BODY_FORCE_Y); -NODES[3301].Fix(BODY_FORCE_Z); -NODES[3302].Fix(BODY_FORCE_X); -NODES[3302].Fix(BODY_FORCE_Y); -NODES[3302].Fix(BODY_FORCE_Z); -NODES[3303].Fix(BODY_FORCE_X); -NODES[3303].Fix(BODY_FORCE_Y); -NODES[3303].Fix(BODY_FORCE_Z); -NODES[3304].Fix(BODY_FORCE_X); -NODES[3304].Fix(BODY_FORCE_Y); -NODES[3304].Fix(BODY_FORCE_Z); -NODES[3305].Fix(BODY_FORCE_X); -NODES[3305].Fix(BODY_FORCE_Y); -NODES[3305].Fix(BODY_FORCE_Z); -NODES[3306].Fix(BODY_FORCE_X); -NODES[3306].Fix(BODY_FORCE_Y); -NODES[3306].Fix(BODY_FORCE_Z); -NODES[3307].Fix(BODY_FORCE_X); -NODES[3307].Fix(BODY_FORCE_Y); -NODES[3307].Fix(BODY_FORCE_Z); -NODES[3308].Fix(BODY_FORCE_X); -NODES[3308].Fix(BODY_FORCE_Y); -NODES[3308].Fix(BODY_FORCE_Z); -NODES[3309].Fix(BODY_FORCE_X); -NODES[3309].Fix(BODY_FORCE_Y); -NODES[3309].Fix(BODY_FORCE_Z); -NODES[3310].Fix(BODY_FORCE_X); -NODES[3310].Fix(BODY_FORCE_Y); -NODES[3310].Fix(BODY_FORCE_Z); -NODES[3311].Fix(BODY_FORCE_X); -NODES[3311].Fix(BODY_FORCE_Y); -NODES[3311].Fix(BODY_FORCE_Z); -NODES[3312].Fix(BODY_FORCE_X); -NODES[3312].Fix(BODY_FORCE_Y); -NODES[3312].Fix(BODY_FORCE_Z); -NODES[3313].Fix(BODY_FORCE_X); -NODES[3313].Fix(BODY_FORCE_Y); -NODES[3313].Fix(BODY_FORCE_Z); -NODES[3314].Fix(BODY_FORCE_X); -NODES[3314].Fix(BODY_FORCE_Y); -NODES[3314].Fix(BODY_FORCE_Z); -NODES[3315].Fix(BODY_FORCE_X); -NODES[3315].Fix(BODY_FORCE_Y); -NODES[3315].Fix(BODY_FORCE_Z); -NODES[3316].Fix(BODY_FORCE_X); -NODES[3316].Fix(BODY_FORCE_Y); -NODES[3316].Fix(BODY_FORCE_Z); -NODES[3317].Fix(BODY_FORCE_X); -NODES[3317].Fix(BODY_FORCE_Y); -NODES[3317].Fix(BODY_FORCE_Z); -NODES[3318].Fix(BODY_FORCE_X); -NODES[3318].Fix(BODY_FORCE_Y); -NODES[3318].Fix(BODY_FORCE_Z); -NODES[3319].Fix(BODY_FORCE_X); -NODES[3319].Fix(BODY_FORCE_Y); -NODES[3319].Fix(BODY_FORCE_Z); -NODES[3320].Fix(BODY_FORCE_X); -NODES[3320].Fix(BODY_FORCE_Y); -NODES[3320].Fix(BODY_FORCE_Z); -NODES[3321].Fix(BODY_FORCE_X); -NODES[3321].Fix(BODY_FORCE_Y); -NODES[3321].Fix(BODY_FORCE_Z); -NODES[3322].Fix(BODY_FORCE_X); -NODES[3322].Fix(BODY_FORCE_Y); -NODES[3322].Fix(BODY_FORCE_Z); -NODES[3324].Fix(BODY_FORCE_X); -NODES[3324].Fix(BODY_FORCE_Y); -NODES[3324].Fix(BODY_FORCE_Z); -NODES[3325].Fix(BODY_FORCE_X); -NODES[3325].Fix(BODY_FORCE_Y); -NODES[3325].Fix(BODY_FORCE_Z); -NODES[3326].Fix(BODY_FORCE_X); -NODES[3326].Fix(BODY_FORCE_Y); -NODES[3326].Fix(BODY_FORCE_Z); -NODES[3327].Fix(BODY_FORCE_X); -NODES[3327].Fix(BODY_FORCE_Y); -NODES[3327].Fix(BODY_FORCE_Z); -NODES[3328].Fix(BODY_FORCE_X); -NODES[3328].Fix(BODY_FORCE_Y); -NODES[3328].Fix(BODY_FORCE_Z); -NODES[3329].Fix(BODY_FORCE_X); -NODES[3329].Fix(BODY_FORCE_Y); -NODES[3329].Fix(BODY_FORCE_Z); -NODES[3330].Fix(BODY_FORCE_X); -NODES[3330].Fix(BODY_FORCE_Y); -NODES[3330].Fix(BODY_FORCE_Z); -NODES[3331].Fix(BODY_FORCE_X); -NODES[3331].Fix(BODY_FORCE_Y); -NODES[3331].Fix(BODY_FORCE_Z); -NODES[3332].Fix(BODY_FORCE_X); -NODES[3332].Fix(BODY_FORCE_Y); -NODES[3332].Fix(BODY_FORCE_Z); -NODES[3333].Fix(BODY_FORCE_X); -NODES[3333].Fix(BODY_FORCE_Y); -NODES[3333].Fix(BODY_FORCE_Z); -NODES[3334].Fix(BODY_FORCE_X); -NODES[3334].Fix(BODY_FORCE_Y); -NODES[3334].Fix(BODY_FORCE_Z); -NODES[3335].Fix(BODY_FORCE_X); -NODES[3335].Fix(BODY_FORCE_Y); -NODES[3335].Fix(BODY_FORCE_Z); -NODES[3336].Fix(BODY_FORCE_X); -NODES[3336].Fix(BODY_FORCE_Y); -NODES[3336].Fix(BODY_FORCE_Z); -NODES[3337].Fix(BODY_FORCE_X); -NODES[3337].Fix(BODY_FORCE_Y); -NODES[3337].Fix(BODY_FORCE_Z); -NODES[3338].Fix(BODY_FORCE_X); -NODES[3338].Fix(BODY_FORCE_Y); -NODES[3338].Fix(BODY_FORCE_Z); -NODES[3339].Fix(BODY_FORCE_X); -NODES[3339].Fix(BODY_FORCE_Y); -NODES[3339].Fix(BODY_FORCE_Z); -NODES[3340].Fix(BODY_FORCE_X); -NODES[3340].Fix(BODY_FORCE_Y); -NODES[3340].Fix(BODY_FORCE_Z); -NODES[3341].Fix(BODY_FORCE_X); -NODES[3341].Fix(BODY_FORCE_Y); -NODES[3341].Fix(BODY_FORCE_Z); -NODES[3342].Fix(BODY_FORCE_X); -NODES[3342].Fix(BODY_FORCE_Y); -NODES[3342].Fix(BODY_FORCE_Z); -NODES[3343].Fix(BODY_FORCE_X); -NODES[3343].Fix(BODY_FORCE_Y); -NODES[3343].Fix(BODY_FORCE_Z); -NODES[3344].Fix(BODY_FORCE_X); -NODES[3344].Fix(BODY_FORCE_Y); -NODES[3344].Fix(BODY_FORCE_Z); -NODES[3345].Fix(BODY_FORCE_X); -NODES[3345].Fix(BODY_FORCE_Y); -NODES[3345].Fix(BODY_FORCE_Z); -NODES[3346].Fix(BODY_FORCE_X); -NODES[3346].Fix(BODY_FORCE_Y); -NODES[3346].Fix(BODY_FORCE_Z); -NODES[3347].Fix(BODY_FORCE_X); -NODES[3347].Fix(BODY_FORCE_Y); -NODES[3347].Fix(BODY_FORCE_Z); -NODES[3348].Fix(BODY_FORCE_X); -NODES[3348].Fix(BODY_FORCE_Y); -NODES[3348].Fix(BODY_FORCE_Z); -NODES[3350].Fix(BODY_FORCE_X); -NODES[3350].Fix(BODY_FORCE_Y); -NODES[3350].Fix(BODY_FORCE_Z); -NODES[3351].Fix(BODY_FORCE_X); -NODES[3351].Fix(BODY_FORCE_Y); -NODES[3351].Fix(BODY_FORCE_Z); -NODES[3352].Fix(BODY_FORCE_X); -NODES[3352].Fix(BODY_FORCE_Y); -NODES[3352].Fix(BODY_FORCE_Z); -NODES[3353].Fix(BODY_FORCE_X); -NODES[3353].Fix(BODY_FORCE_Y); -NODES[3353].Fix(BODY_FORCE_Z); -NODES[3354].Fix(BODY_FORCE_X); -NODES[3354].Fix(BODY_FORCE_Y); -NODES[3354].Fix(BODY_FORCE_Z); -NODES[3355].Fix(BODY_FORCE_X); -NODES[3355].Fix(BODY_FORCE_Y); -NODES[3355].Fix(BODY_FORCE_Z); -NODES[3356].Fix(BODY_FORCE_X); -NODES[3356].Fix(BODY_FORCE_Y); -NODES[3356].Fix(BODY_FORCE_Z); -NODES[3357].Fix(BODY_FORCE_X); -NODES[3357].Fix(BODY_FORCE_Y); -NODES[3357].Fix(BODY_FORCE_Z); -NODES[3358].Fix(BODY_FORCE_X); -NODES[3358].Fix(BODY_FORCE_Y); -NODES[3358].Fix(BODY_FORCE_Z); -NODES[3359].Fix(BODY_FORCE_X); -NODES[3359].Fix(BODY_FORCE_Y); -NODES[3359].Fix(BODY_FORCE_Z); -NODES[3360].Fix(BODY_FORCE_X); -NODES[3360].Fix(BODY_FORCE_Y); -NODES[3360].Fix(BODY_FORCE_Z); -NODES[3361].Fix(BODY_FORCE_X); -NODES[3361].Fix(BODY_FORCE_Y); -NODES[3361].Fix(BODY_FORCE_Z); -NODES[3362].Fix(BODY_FORCE_X); -NODES[3362].Fix(BODY_FORCE_Y); -NODES[3362].Fix(BODY_FORCE_Z); -NODES[3363].Fix(BODY_FORCE_X); -NODES[3363].Fix(BODY_FORCE_Y); -NODES[3363].Fix(BODY_FORCE_Z); -NODES[3364].Fix(BODY_FORCE_X); -NODES[3364].Fix(BODY_FORCE_Y); -NODES[3364].Fix(BODY_FORCE_Z); -NODES[3365].Fix(BODY_FORCE_X); -NODES[3365].Fix(BODY_FORCE_Y); -NODES[3365].Fix(BODY_FORCE_Z); -NODES[3366].Fix(BODY_FORCE_X); -NODES[3366].Fix(BODY_FORCE_Y); -NODES[3366].Fix(BODY_FORCE_Z); -NODES[3367].Fix(BODY_FORCE_X); -NODES[3367].Fix(BODY_FORCE_Y); -NODES[3367].Fix(BODY_FORCE_Z); -NODES[3368].Fix(BODY_FORCE_X); -NODES[3368].Fix(BODY_FORCE_Y); -NODES[3368].Fix(BODY_FORCE_Z); -NODES[3369].Fix(BODY_FORCE_X); -NODES[3369].Fix(BODY_FORCE_Y); -NODES[3369].Fix(BODY_FORCE_Z); -NODES[3370].Fix(BODY_FORCE_X); -NODES[3370].Fix(BODY_FORCE_Y); -NODES[3370].Fix(BODY_FORCE_Z); -NODES[3371].Fix(BODY_FORCE_X); -NODES[3371].Fix(BODY_FORCE_Y); -NODES[3371].Fix(BODY_FORCE_Z); -NODES[3372].Fix(BODY_FORCE_X); -NODES[3372].Fix(BODY_FORCE_Y); -NODES[3372].Fix(BODY_FORCE_Z); -NODES[3373].Fix(BODY_FORCE_X); -NODES[3373].Fix(BODY_FORCE_Y); -NODES[3373].Fix(BODY_FORCE_Z); -NODES[3374].Fix(BODY_FORCE_X); -NODES[3374].Fix(BODY_FORCE_Y); -NODES[3374].Fix(BODY_FORCE_Z); -NODES[3376].Fix(BODY_FORCE_X); -NODES[3376].Fix(BODY_FORCE_Y); -NODES[3376].Fix(BODY_FORCE_Z); -NODES[3377].Fix(BODY_FORCE_X); -NODES[3377].Fix(BODY_FORCE_Y); -NODES[3377].Fix(BODY_FORCE_Z); -NODES[3378].Fix(BODY_FORCE_X); -NODES[3378].Fix(BODY_FORCE_Y); -NODES[3378].Fix(BODY_FORCE_Z); -NODES[3379].Fix(BODY_FORCE_X); -NODES[3379].Fix(BODY_FORCE_Y); -NODES[3379].Fix(BODY_FORCE_Z); -NODES[3380].Fix(BODY_FORCE_X); -NODES[3380].Fix(BODY_FORCE_Y); -NODES[3380].Fix(BODY_FORCE_Z); -NODES[3381].Fix(BODY_FORCE_X); -NODES[3381].Fix(BODY_FORCE_Y); -NODES[3381].Fix(BODY_FORCE_Z); -NODES[3382].Fix(BODY_FORCE_X); -NODES[3382].Fix(BODY_FORCE_Y); -NODES[3382].Fix(BODY_FORCE_Z); -NODES[3383].Fix(BODY_FORCE_X); -NODES[3383].Fix(BODY_FORCE_Y); -NODES[3383].Fix(BODY_FORCE_Z); -NODES[3384].Fix(BODY_FORCE_X); -NODES[3384].Fix(BODY_FORCE_Y); -NODES[3384].Fix(BODY_FORCE_Z); -NODES[3385].Fix(BODY_FORCE_X); -NODES[3385].Fix(BODY_FORCE_Y); -NODES[3385].Fix(BODY_FORCE_Z); -NODES[3386].Fix(BODY_FORCE_X); -NODES[3386].Fix(BODY_FORCE_Y); -NODES[3386].Fix(BODY_FORCE_Z); -NODES[3387].Fix(BODY_FORCE_X); -NODES[3387].Fix(BODY_FORCE_Y); -NODES[3387].Fix(BODY_FORCE_Z); -NODES[3388].Fix(BODY_FORCE_X); -NODES[3388].Fix(BODY_FORCE_Y); -NODES[3388].Fix(BODY_FORCE_Z); -NODES[3389].Fix(BODY_FORCE_X); -NODES[3389].Fix(BODY_FORCE_Y); -NODES[3389].Fix(BODY_FORCE_Z); -NODES[3390].Fix(BODY_FORCE_X); -NODES[3390].Fix(BODY_FORCE_Y); -NODES[3390].Fix(BODY_FORCE_Z); -NODES[3391].Fix(BODY_FORCE_X); -NODES[3391].Fix(BODY_FORCE_Y); -NODES[3391].Fix(BODY_FORCE_Z); -NODES[3392].Fix(BODY_FORCE_X); -NODES[3392].Fix(BODY_FORCE_Y); -NODES[3392].Fix(BODY_FORCE_Z); -NODES[3393].Fix(BODY_FORCE_X); -NODES[3393].Fix(BODY_FORCE_Y); -NODES[3393].Fix(BODY_FORCE_Z); -NODES[3394].Fix(BODY_FORCE_X); -NODES[3394].Fix(BODY_FORCE_Y); -NODES[3394].Fix(BODY_FORCE_Z); -NODES[3395].Fix(BODY_FORCE_X); -NODES[3395].Fix(BODY_FORCE_Y); -NODES[3395].Fix(BODY_FORCE_Z); -NODES[3396].Fix(BODY_FORCE_X); -NODES[3396].Fix(BODY_FORCE_Y); -NODES[3396].Fix(BODY_FORCE_Z); -NODES[3397].Fix(BODY_FORCE_X); -NODES[3397].Fix(BODY_FORCE_Y); -NODES[3397].Fix(BODY_FORCE_Z); -NODES[3398].Fix(BODY_FORCE_X); -NODES[3398].Fix(BODY_FORCE_Y); -NODES[3398].Fix(BODY_FORCE_Z); -NODES[3399].Fix(BODY_FORCE_X); -NODES[3399].Fix(BODY_FORCE_Y); -NODES[3399].Fix(BODY_FORCE_Z); -NODES[3400].Fix(BODY_FORCE_X); -NODES[3400].Fix(BODY_FORCE_Y); -NODES[3400].Fix(BODY_FORCE_Z); -NODES[3402].Fix(BODY_FORCE_X); -NODES[3402].Fix(BODY_FORCE_Y); -NODES[3402].Fix(BODY_FORCE_Z); -NODES[3403].Fix(BODY_FORCE_X); -NODES[3403].Fix(BODY_FORCE_Y); -NODES[3403].Fix(BODY_FORCE_Z); -NODES[3404].Fix(BODY_FORCE_X); -NODES[3404].Fix(BODY_FORCE_Y); -NODES[3404].Fix(BODY_FORCE_Z); -NODES[3405].Fix(BODY_FORCE_X); -NODES[3405].Fix(BODY_FORCE_Y); -NODES[3405].Fix(BODY_FORCE_Z); -NODES[3406].Fix(BODY_FORCE_X); -NODES[3406].Fix(BODY_FORCE_Y); -NODES[3406].Fix(BODY_FORCE_Z); -NODES[3407].Fix(BODY_FORCE_X); -NODES[3407].Fix(BODY_FORCE_Y); -NODES[3407].Fix(BODY_FORCE_Z); -NODES[3408].Fix(BODY_FORCE_X); -NODES[3408].Fix(BODY_FORCE_Y); -NODES[3408].Fix(BODY_FORCE_Z); -NODES[3409].Fix(BODY_FORCE_X); -NODES[3409].Fix(BODY_FORCE_Y); -NODES[3409].Fix(BODY_FORCE_Z); -NODES[3410].Fix(BODY_FORCE_X); -NODES[3410].Fix(BODY_FORCE_Y); -NODES[3410].Fix(BODY_FORCE_Z); -NODES[3411].Fix(BODY_FORCE_X); -NODES[3411].Fix(BODY_FORCE_Y); -NODES[3411].Fix(BODY_FORCE_Z); -NODES[3412].Fix(BODY_FORCE_X); -NODES[3412].Fix(BODY_FORCE_Y); -NODES[3412].Fix(BODY_FORCE_Z); -NODES[3413].Fix(BODY_FORCE_X); -NODES[3413].Fix(BODY_FORCE_Y); -NODES[3413].Fix(BODY_FORCE_Z); -NODES[3414].Fix(BODY_FORCE_X); -NODES[3414].Fix(BODY_FORCE_Y); -NODES[3414].Fix(BODY_FORCE_Z); -NODES[3415].Fix(BODY_FORCE_X); -NODES[3415].Fix(BODY_FORCE_Y); -NODES[3415].Fix(BODY_FORCE_Z); -NODES[3416].Fix(BODY_FORCE_X); -NODES[3416].Fix(BODY_FORCE_Y); -NODES[3416].Fix(BODY_FORCE_Z); -NODES[3417].Fix(BODY_FORCE_X); -NODES[3417].Fix(BODY_FORCE_Y); -NODES[3417].Fix(BODY_FORCE_Z); -NODES[3418].Fix(BODY_FORCE_X); -NODES[3418].Fix(BODY_FORCE_Y); -NODES[3418].Fix(BODY_FORCE_Z); -NODES[3419].Fix(BODY_FORCE_X); -NODES[3419].Fix(BODY_FORCE_Y); -NODES[3419].Fix(BODY_FORCE_Z); -NODES[3420].Fix(BODY_FORCE_X); -NODES[3420].Fix(BODY_FORCE_Y); -NODES[3420].Fix(BODY_FORCE_Z); -NODES[3421].Fix(BODY_FORCE_X); -NODES[3421].Fix(BODY_FORCE_Y); -NODES[3421].Fix(BODY_FORCE_Z); -NODES[3422].Fix(BODY_FORCE_X); -NODES[3422].Fix(BODY_FORCE_Y); -NODES[3422].Fix(BODY_FORCE_Z); -NODES[3423].Fix(BODY_FORCE_X); -NODES[3423].Fix(BODY_FORCE_Y); -NODES[3423].Fix(BODY_FORCE_Z); -NODES[3424].Fix(BODY_FORCE_X); -NODES[3424].Fix(BODY_FORCE_Y); -NODES[3424].Fix(BODY_FORCE_Z); -NODES[3425].Fix(BODY_FORCE_X); -NODES[3425].Fix(BODY_FORCE_Y); -NODES[3425].Fix(BODY_FORCE_Z); -NODES[3427].Fix(BODY_FORCE_X); -NODES[3427].Fix(BODY_FORCE_Y); -NODES[3427].Fix(BODY_FORCE_Z); -NODES[3428].Fix(BODY_FORCE_X); -NODES[3428].Fix(BODY_FORCE_Y); -NODES[3428].Fix(BODY_FORCE_Z); -NODES[3429].Fix(BODY_FORCE_X); -NODES[3429].Fix(BODY_FORCE_Y); -NODES[3429].Fix(BODY_FORCE_Z); -NODES[3430].Fix(BODY_FORCE_X); -NODES[3430].Fix(BODY_FORCE_Y); -NODES[3430].Fix(BODY_FORCE_Z); -NODES[3431].Fix(BODY_FORCE_X); -NODES[3431].Fix(BODY_FORCE_Y); -NODES[3431].Fix(BODY_FORCE_Z); -NODES[3432].Fix(BODY_FORCE_X); -NODES[3432].Fix(BODY_FORCE_Y); -NODES[3432].Fix(BODY_FORCE_Z); -NODES[3433].Fix(BODY_FORCE_X); -NODES[3433].Fix(BODY_FORCE_Y); -NODES[3433].Fix(BODY_FORCE_Z); -NODES[3434].Fix(BODY_FORCE_X); -NODES[3434].Fix(BODY_FORCE_Y); -NODES[3434].Fix(BODY_FORCE_Z); -NODES[3435].Fix(BODY_FORCE_X); -NODES[3435].Fix(BODY_FORCE_Y); -NODES[3435].Fix(BODY_FORCE_Z); -NODES[3436].Fix(BODY_FORCE_X); -NODES[3436].Fix(BODY_FORCE_Y); -NODES[3436].Fix(BODY_FORCE_Z); -NODES[3437].Fix(BODY_FORCE_X); -NODES[3437].Fix(BODY_FORCE_Y); -NODES[3437].Fix(BODY_FORCE_Z); -NODES[3438].Fix(BODY_FORCE_X); -NODES[3438].Fix(BODY_FORCE_Y); -NODES[3438].Fix(BODY_FORCE_Z); -NODES[3439].Fix(BODY_FORCE_X); -NODES[3439].Fix(BODY_FORCE_Y); -NODES[3439].Fix(BODY_FORCE_Z); -NODES[3440].Fix(BODY_FORCE_X); -NODES[3440].Fix(BODY_FORCE_Y); -NODES[3440].Fix(BODY_FORCE_Z); -NODES[3441].Fix(BODY_FORCE_X); -NODES[3441].Fix(BODY_FORCE_Y); -NODES[3441].Fix(BODY_FORCE_Z); -NODES[3442].Fix(BODY_FORCE_X); -NODES[3442].Fix(BODY_FORCE_Y); -NODES[3442].Fix(BODY_FORCE_Z); -NODES[3443].Fix(BODY_FORCE_X); -NODES[3443].Fix(BODY_FORCE_Y); -NODES[3443].Fix(BODY_FORCE_Z); -NODES[3444].Fix(BODY_FORCE_X); -NODES[3444].Fix(BODY_FORCE_Y); -NODES[3444].Fix(BODY_FORCE_Z); -NODES[3445].Fix(BODY_FORCE_X); -NODES[3445].Fix(BODY_FORCE_Y); -NODES[3445].Fix(BODY_FORCE_Z); -NODES[3446].Fix(BODY_FORCE_X); -NODES[3446].Fix(BODY_FORCE_Y); -NODES[3446].Fix(BODY_FORCE_Z); -NODES[3447].Fix(BODY_FORCE_X); -NODES[3447].Fix(BODY_FORCE_Y); -NODES[3447].Fix(BODY_FORCE_Z); -NODES[3448].Fix(BODY_FORCE_X); -NODES[3448].Fix(BODY_FORCE_Y); -NODES[3448].Fix(BODY_FORCE_Z); -NODES[3449].Fix(BODY_FORCE_X); -NODES[3449].Fix(BODY_FORCE_Y); -NODES[3449].Fix(BODY_FORCE_Z); -NODES[3450].Fix(BODY_FORCE_X); -NODES[3450].Fix(BODY_FORCE_Y); -NODES[3450].Fix(BODY_FORCE_Z); -NODES[3451].Fix(BODY_FORCE_X); -NODES[3451].Fix(BODY_FORCE_Y); -NODES[3451].Fix(BODY_FORCE_Z); -NODES[3452].Fix(BODY_FORCE_X); -NODES[3452].Fix(BODY_FORCE_Y); -NODES[3452].Fix(BODY_FORCE_Z); -NODES[3453].Fix(BODY_FORCE_X); -NODES[3453].Fix(BODY_FORCE_Y); -NODES[3453].Fix(BODY_FORCE_Z); -NODES[3454].Fix(BODY_FORCE_X); -NODES[3454].Fix(BODY_FORCE_Y); -NODES[3454].Fix(BODY_FORCE_Z); -NODES[3455].Fix(BODY_FORCE_X); -NODES[3455].Fix(BODY_FORCE_Y); -NODES[3455].Fix(BODY_FORCE_Z); -NODES[3456].Fix(BODY_FORCE_X); -NODES[3456].Fix(BODY_FORCE_Y); -NODES[3456].Fix(BODY_FORCE_Z); -NODES[3457].Fix(BODY_FORCE_X); -NODES[3457].Fix(BODY_FORCE_Y); -NODES[3457].Fix(BODY_FORCE_Z); -NODES[3458].Fix(BODY_FORCE_X); -NODES[3458].Fix(BODY_FORCE_Y); -NODES[3458].Fix(BODY_FORCE_Z); -NODES[3460].Fix(BODY_FORCE_X); -NODES[3460].Fix(BODY_FORCE_Y); -NODES[3460].Fix(BODY_FORCE_Z); -NODES[3461].Fix(BODY_FORCE_X); -NODES[3461].Fix(BODY_FORCE_Y); -NODES[3461].Fix(BODY_FORCE_Z); -NODES[3462].Fix(BODY_FORCE_X); -NODES[3462].Fix(BODY_FORCE_Y); -NODES[3462].Fix(BODY_FORCE_Z); -NODES[3463].Fix(BODY_FORCE_X); -NODES[3463].Fix(BODY_FORCE_Y); -NODES[3463].Fix(BODY_FORCE_Z); -NODES[3464].Fix(BODY_FORCE_X); -NODES[3464].Fix(BODY_FORCE_Y); -NODES[3464].Fix(BODY_FORCE_Z); -NODES[3465].Fix(BODY_FORCE_X); -NODES[3465].Fix(BODY_FORCE_Y); -NODES[3465].Fix(BODY_FORCE_Z); -NODES[3466].Fix(BODY_FORCE_X); -NODES[3466].Fix(BODY_FORCE_Y); -NODES[3466].Fix(BODY_FORCE_Z); -NODES[3467].Fix(BODY_FORCE_X); -NODES[3467].Fix(BODY_FORCE_Y); -NODES[3467].Fix(BODY_FORCE_Z); -NODES[3468].Fix(BODY_FORCE_X); -NODES[3468].Fix(BODY_FORCE_Y); -NODES[3468].Fix(BODY_FORCE_Z); -NODES[3469].Fix(BODY_FORCE_X); -NODES[3469].Fix(BODY_FORCE_Y); -NODES[3469].Fix(BODY_FORCE_Z); -NODES[3470].Fix(BODY_FORCE_X); -NODES[3470].Fix(BODY_FORCE_Y); -NODES[3470].Fix(BODY_FORCE_Z); -NODES[3471].Fix(BODY_FORCE_X); -NODES[3471].Fix(BODY_FORCE_Y); -NODES[3471].Fix(BODY_FORCE_Z); -NODES[3472].Fix(BODY_FORCE_X); -NODES[3472].Fix(BODY_FORCE_Y); -NODES[3472].Fix(BODY_FORCE_Z); -NODES[3473].Fix(BODY_FORCE_X); -NODES[3473].Fix(BODY_FORCE_Y); -NODES[3473].Fix(BODY_FORCE_Z); -NODES[3474].Fix(BODY_FORCE_X); -NODES[3474].Fix(BODY_FORCE_Y); -NODES[3474].Fix(BODY_FORCE_Z); -NODES[3475].Fix(BODY_FORCE_X); -NODES[3475].Fix(BODY_FORCE_Y); -NODES[3475].Fix(BODY_FORCE_Z); -NODES[3476].Fix(BODY_FORCE_X); -NODES[3476].Fix(BODY_FORCE_Y); -NODES[3476].Fix(BODY_FORCE_Z); -NODES[3477].Fix(BODY_FORCE_X); -NODES[3477].Fix(BODY_FORCE_Y); -NODES[3477].Fix(BODY_FORCE_Z); -NODES[3478].Fix(BODY_FORCE_X); -NODES[3478].Fix(BODY_FORCE_Y); -NODES[3478].Fix(BODY_FORCE_Z); -NODES[3479].Fix(BODY_FORCE_X); -NODES[3479].Fix(BODY_FORCE_Y); -NODES[3479].Fix(BODY_FORCE_Z); -NODES[3480].Fix(BODY_FORCE_X); -NODES[3480].Fix(BODY_FORCE_Y); -NODES[3480].Fix(BODY_FORCE_Z); -NODES[3481].Fix(BODY_FORCE_X); -NODES[3481].Fix(BODY_FORCE_Y); -NODES[3481].Fix(BODY_FORCE_Z); -NODES[3482].Fix(BODY_FORCE_X); -NODES[3482].Fix(BODY_FORCE_Y); -NODES[3482].Fix(BODY_FORCE_Z); -NODES[3483].Fix(BODY_FORCE_X); -NODES[3483].Fix(BODY_FORCE_Y); -NODES[3483].Fix(BODY_FORCE_Z); -NODES[3484].Fix(BODY_FORCE_X); -NODES[3484].Fix(BODY_FORCE_Y); -NODES[3484].Fix(BODY_FORCE_Z); -NODES[3486].Fix(BODY_FORCE_X); -NODES[3486].Fix(BODY_FORCE_Y); -NODES[3486].Fix(BODY_FORCE_Z); -NODES[3487].Fix(BODY_FORCE_X); -NODES[3487].Fix(BODY_FORCE_Y); -NODES[3487].Fix(BODY_FORCE_Z); -NODES[3488].Fix(BODY_FORCE_X); -NODES[3488].Fix(BODY_FORCE_Y); -NODES[3488].Fix(BODY_FORCE_Z); -NODES[3489].Fix(BODY_FORCE_X); -NODES[3489].Fix(BODY_FORCE_Y); -NODES[3489].Fix(BODY_FORCE_Z); -NODES[3490].Fix(BODY_FORCE_X); -NODES[3490].Fix(BODY_FORCE_Y); -NODES[3490].Fix(BODY_FORCE_Z); -NODES[3491].Fix(BODY_FORCE_X); -NODES[3491].Fix(BODY_FORCE_Y); -NODES[3491].Fix(BODY_FORCE_Z); -NODES[3492].Fix(BODY_FORCE_X); -NODES[3492].Fix(BODY_FORCE_Y); -NODES[3492].Fix(BODY_FORCE_Z); -NODES[3493].Fix(BODY_FORCE_X); -NODES[3493].Fix(BODY_FORCE_Y); -NODES[3493].Fix(BODY_FORCE_Z); -NODES[3494].Fix(BODY_FORCE_X); -NODES[3494].Fix(BODY_FORCE_Y); -NODES[3494].Fix(BODY_FORCE_Z); -NODES[3495].Fix(BODY_FORCE_X); -NODES[3495].Fix(BODY_FORCE_Y); -NODES[3495].Fix(BODY_FORCE_Z); -NODES[3496].Fix(BODY_FORCE_X); -NODES[3496].Fix(BODY_FORCE_Y); -NODES[3496].Fix(BODY_FORCE_Z); -NODES[3497].Fix(BODY_FORCE_X); -NODES[3497].Fix(BODY_FORCE_Y); -NODES[3497].Fix(BODY_FORCE_Z); -NODES[3498].Fix(BODY_FORCE_X); -NODES[3498].Fix(BODY_FORCE_Y); -NODES[3498].Fix(BODY_FORCE_Z); -NODES[3499].Fix(BODY_FORCE_X); -NODES[3499].Fix(BODY_FORCE_Y); -NODES[3499].Fix(BODY_FORCE_Z); -NODES[3500].Fix(BODY_FORCE_X); -NODES[3500].Fix(BODY_FORCE_Y); -NODES[3500].Fix(BODY_FORCE_Z); -NODES[3501].Fix(BODY_FORCE_X); -NODES[3501].Fix(BODY_FORCE_Y); -NODES[3501].Fix(BODY_FORCE_Z); -NODES[3502].Fix(BODY_FORCE_X); -NODES[3502].Fix(BODY_FORCE_Y); -NODES[3502].Fix(BODY_FORCE_Z); -NODES[3503].Fix(BODY_FORCE_X); -NODES[3503].Fix(BODY_FORCE_Y); -NODES[3503].Fix(BODY_FORCE_Z); -NODES[3504].Fix(BODY_FORCE_X); -NODES[3504].Fix(BODY_FORCE_Y); -NODES[3504].Fix(BODY_FORCE_Z); -NODES[3505].Fix(BODY_FORCE_X); -NODES[3505].Fix(BODY_FORCE_Y); -NODES[3505].Fix(BODY_FORCE_Z); -NODES[3506].Fix(BODY_FORCE_X); -NODES[3506].Fix(BODY_FORCE_Y); -NODES[3506].Fix(BODY_FORCE_Z); -NODES[3507].Fix(BODY_FORCE_X); -NODES[3507].Fix(BODY_FORCE_Y); -NODES[3507].Fix(BODY_FORCE_Z); -NODES[3508].Fix(BODY_FORCE_X); -NODES[3508].Fix(BODY_FORCE_Y); -NODES[3508].Fix(BODY_FORCE_Z); -NODES[3509].Fix(BODY_FORCE_X); -NODES[3509].Fix(BODY_FORCE_Y); -NODES[3509].Fix(BODY_FORCE_Z); -NODES[3510].Fix(BODY_FORCE_X); -NODES[3510].Fix(BODY_FORCE_Y); -NODES[3510].Fix(BODY_FORCE_Z); -NODES[3511].Fix(BODY_FORCE_X); -NODES[3511].Fix(BODY_FORCE_Y); -NODES[3511].Fix(BODY_FORCE_Z); -NODES[3513].Fix(BODY_FORCE_X); -NODES[3513].Fix(BODY_FORCE_Y); -NODES[3513].Fix(BODY_FORCE_Z); -NODES[3514].Fix(BODY_FORCE_X); -NODES[3514].Fix(BODY_FORCE_Y); -NODES[3514].Fix(BODY_FORCE_Z); -NODES[3515].Fix(BODY_FORCE_X); -NODES[3515].Fix(BODY_FORCE_Y); -NODES[3515].Fix(BODY_FORCE_Z); -NODES[3516].Fix(BODY_FORCE_X); -NODES[3516].Fix(BODY_FORCE_Y); -NODES[3516].Fix(BODY_FORCE_Z); -NODES[3517].Fix(BODY_FORCE_X); -NODES[3517].Fix(BODY_FORCE_Y); -NODES[3517].Fix(BODY_FORCE_Z); -NODES[3518].Fix(BODY_FORCE_X); -NODES[3518].Fix(BODY_FORCE_Y); -NODES[3518].Fix(BODY_FORCE_Z); -NODES[3519].Fix(BODY_FORCE_X); -NODES[3519].Fix(BODY_FORCE_Y); -NODES[3519].Fix(BODY_FORCE_Z); -NODES[3520].Fix(BODY_FORCE_X); -NODES[3520].Fix(BODY_FORCE_Y); -NODES[3520].Fix(BODY_FORCE_Z); -NODES[3521].Fix(BODY_FORCE_X); -NODES[3521].Fix(BODY_FORCE_Y); -NODES[3521].Fix(BODY_FORCE_Z); -NODES[3522].Fix(BODY_FORCE_X); -NODES[3522].Fix(BODY_FORCE_Y); -NODES[3522].Fix(BODY_FORCE_Z); -NODES[3523].Fix(BODY_FORCE_X); -NODES[3523].Fix(BODY_FORCE_Y); -NODES[3523].Fix(BODY_FORCE_Z); -NODES[3524].Fix(BODY_FORCE_X); -NODES[3524].Fix(BODY_FORCE_Y); -NODES[3524].Fix(BODY_FORCE_Z); -NODES[3525].Fix(BODY_FORCE_X); -NODES[3525].Fix(BODY_FORCE_Y); -NODES[3525].Fix(BODY_FORCE_Z); -NODES[3526].Fix(BODY_FORCE_X); -NODES[3526].Fix(BODY_FORCE_Y); -NODES[3526].Fix(BODY_FORCE_Z); -NODES[3527].Fix(BODY_FORCE_X); -NODES[3527].Fix(BODY_FORCE_Y); -NODES[3527].Fix(BODY_FORCE_Z); -NODES[3528].Fix(BODY_FORCE_X); -NODES[3528].Fix(BODY_FORCE_Y); -NODES[3528].Fix(BODY_FORCE_Z); -NODES[3529].Fix(BODY_FORCE_X); -NODES[3529].Fix(BODY_FORCE_Y); -NODES[3529].Fix(BODY_FORCE_Z); -NODES[3530].Fix(BODY_FORCE_X); -NODES[3530].Fix(BODY_FORCE_Y); -NODES[3530].Fix(BODY_FORCE_Z); -NODES[3531].Fix(BODY_FORCE_X); -NODES[3531].Fix(BODY_FORCE_Y); -NODES[3531].Fix(BODY_FORCE_Z); -NODES[3532].Fix(BODY_FORCE_X); -NODES[3532].Fix(BODY_FORCE_Y); -NODES[3532].Fix(BODY_FORCE_Z); -NODES[3533].Fix(BODY_FORCE_X); -NODES[3533].Fix(BODY_FORCE_Y); -NODES[3533].Fix(BODY_FORCE_Z); -NODES[3534].Fix(BODY_FORCE_X); -NODES[3534].Fix(BODY_FORCE_Y); -NODES[3534].Fix(BODY_FORCE_Z); -NODES[3535].Fix(BODY_FORCE_X); -NODES[3535].Fix(BODY_FORCE_Y); -NODES[3535].Fix(BODY_FORCE_Z); -NODES[3536].Fix(BODY_FORCE_X); -NODES[3536].Fix(BODY_FORCE_Y); -NODES[3536].Fix(BODY_FORCE_Z); -NODES[3537].Fix(BODY_FORCE_X); -NODES[3537].Fix(BODY_FORCE_Y); -NODES[3537].Fix(BODY_FORCE_Z); -NODES[3539].Fix(BODY_FORCE_X); -NODES[3539].Fix(BODY_FORCE_Y); -NODES[3539].Fix(BODY_FORCE_Z); -NODES[3540].Fix(BODY_FORCE_X); -NODES[3540].Fix(BODY_FORCE_Y); -NODES[3540].Fix(BODY_FORCE_Z); -NODES[3541].Fix(BODY_FORCE_X); -NODES[3541].Fix(BODY_FORCE_Y); -NODES[3541].Fix(BODY_FORCE_Z); -NODES[3542].Fix(BODY_FORCE_X); -NODES[3542].Fix(BODY_FORCE_Y); -NODES[3542].Fix(BODY_FORCE_Z); -NODES[3543].Fix(BODY_FORCE_X); -NODES[3543].Fix(BODY_FORCE_Y); -NODES[3543].Fix(BODY_FORCE_Z); -NODES[3544].Fix(BODY_FORCE_X); -NODES[3544].Fix(BODY_FORCE_Y); -NODES[3544].Fix(BODY_FORCE_Z); -NODES[3545].Fix(BODY_FORCE_X); -NODES[3545].Fix(BODY_FORCE_Y); -NODES[3545].Fix(BODY_FORCE_Z); -NODES[3546].Fix(BODY_FORCE_X); -NODES[3546].Fix(BODY_FORCE_Y); -NODES[3546].Fix(BODY_FORCE_Z); -NODES[3547].Fix(BODY_FORCE_X); -NODES[3547].Fix(BODY_FORCE_Y); -NODES[3547].Fix(BODY_FORCE_Z); -NODES[3548].Fix(BODY_FORCE_X); -NODES[3548].Fix(BODY_FORCE_Y); -NODES[3548].Fix(BODY_FORCE_Z); -NODES[3549].Fix(BODY_FORCE_X); -NODES[3549].Fix(BODY_FORCE_Y); -NODES[3549].Fix(BODY_FORCE_Z); -NODES[3550].Fix(BODY_FORCE_X); -NODES[3550].Fix(BODY_FORCE_Y); -NODES[3550].Fix(BODY_FORCE_Z); -NODES[3551].Fix(BODY_FORCE_X); -NODES[3551].Fix(BODY_FORCE_Y); -NODES[3551].Fix(BODY_FORCE_Z); -NODES[3552].Fix(BODY_FORCE_X); -NODES[3552].Fix(BODY_FORCE_Y); -NODES[3552].Fix(BODY_FORCE_Z); -NODES[3553].Fix(BODY_FORCE_X); -NODES[3553].Fix(BODY_FORCE_Y); -NODES[3553].Fix(BODY_FORCE_Z); -NODES[3554].Fix(BODY_FORCE_X); -NODES[3554].Fix(BODY_FORCE_Y); -NODES[3554].Fix(BODY_FORCE_Z); -NODES[3555].Fix(BODY_FORCE_X); -NODES[3555].Fix(BODY_FORCE_Y); -NODES[3555].Fix(BODY_FORCE_Z); -NODES[3556].Fix(BODY_FORCE_X); -NODES[3556].Fix(BODY_FORCE_Y); -NODES[3556].Fix(BODY_FORCE_Z); -NODES[3557].Fix(BODY_FORCE_X); -NODES[3557].Fix(BODY_FORCE_Y); -NODES[3557].Fix(BODY_FORCE_Z); -NODES[3558].Fix(BODY_FORCE_X); -NODES[3558].Fix(BODY_FORCE_Y); -NODES[3558].Fix(BODY_FORCE_Z); -NODES[3559].Fix(BODY_FORCE_X); -NODES[3559].Fix(BODY_FORCE_Y); -NODES[3559].Fix(BODY_FORCE_Z); -NODES[3560].Fix(BODY_FORCE_X); -NODES[3560].Fix(BODY_FORCE_Y); -NODES[3560].Fix(BODY_FORCE_Z); -NODES[3561].Fix(BODY_FORCE_X); -NODES[3561].Fix(BODY_FORCE_Y); -NODES[3561].Fix(BODY_FORCE_Z); -NODES[3562].Fix(BODY_FORCE_X); -NODES[3562].Fix(BODY_FORCE_Y); -NODES[3562].Fix(BODY_FORCE_Z); -NODES[3564].Fix(BODY_FORCE_X); -NODES[3564].Fix(BODY_FORCE_Y); -NODES[3564].Fix(BODY_FORCE_Z); -NODES[3565].Fix(BODY_FORCE_X); -NODES[3565].Fix(BODY_FORCE_Y); -NODES[3565].Fix(BODY_FORCE_Z); -NODES[3566].Fix(BODY_FORCE_X); -NODES[3566].Fix(BODY_FORCE_Y); -NODES[3566].Fix(BODY_FORCE_Z); -NODES[3567].Fix(BODY_FORCE_X); -NODES[3567].Fix(BODY_FORCE_Y); -NODES[3567].Fix(BODY_FORCE_Z); -NODES[3568].Fix(BODY_FORCE_X); -NODES[3568].Fix(BODY_FORCE_Y); -NODES[3568].Fix(BODY_FORCE_Z); -NODES[3569].Fix(BODY_FORCE_X); -NODES[3569].Fix(BODY_FORCE_Y); -NODES[3569].Fix(BODY_FORCE_Z); -NODES[3570].Fix(BODY_FORCE_X); -NODES[3570].Fix(BODY_FORCE_Y); -NODES[3570].Fix(BODY_FORCE_Z); -NODES[3571].Fix(BODY_FORCE_X); -NODES[3571].Fix(BODY_FORCE_Y); -NODES[3571].Fix(BODY_FORCE_Z); -NODES[3572].Fix(BODY_FORCE_X); -NODES[3572].Fix(BODY_FORCE_Y); -NODES[3572].Fix(BODY_FORCE_Z); -NODES[3573].Fix(BODY_FORCE_X); -NODES[3573].Fix(BODY_FORCE_Y); -NODES[3573].Fix(BODY_FORCE_Z); -NODES[3574].Fix(BODY_FORCE_X); -NODES[3574].Fix(BODY_FORCE_Y); -NODES[3574].Fix(BODY_FORCE_Z); -NODES[3575].Fix(BODY_FORCE_X); -NODES[3575].Fix(BODY_FORCE_Y); -NODES[3575].Fix(BODY_FORCE_Z); -NODES[3576].Fix(BODY_FORCE_X); -NODES[3576].Fix(BODY_FORCE_Y); -NODES[3576].Fix(BODY_FORCE_Z); -NODES[3577].Fix(BODY_FORCE_X); -NODES[3577].Fix(BODY_FORCE_Y); -NODES[3577].Fix(BODY_FORCE_Z); -NODES[3578].Fix(BODY_FORCE_X); -NODES[3578].Fix(BODY_FORCE_Y); -NODES[3578].Fix(BODY_FORCE_Z); -NODES[3579].Fix(BODY_FORCE_X); -NODES[3579].Fix(BODY_FORCE_Y); -NODES[3579].Fix(BODY_FORCE_Z); -NODES[3580].Fix(BODY_FORCE_X); -NODES[3580].Fix(BODY_FORCE_Y); -NODES[3580].Fix(BODY_FORCE_Z); -NODES[3581].Fix(BODY_FORCE_X); -NODES[3581].Fix(BODY_FORCE_Y); -NODES[3581].Fix(BODY_FORCE_Z); -NODES[3582].Fix(BODY_FORCE_X); -NODES[3582].Fix(BODY_FORCE_Y); -NODES[3582].Fix(BODY_FORCE_Z); -NODES[3583].Fix(BODY_FORCE_X); -NODES[3583].Fix(BODY_FORCE_Y); -NODES[3583].Fix(BODY_FORCE_Z); -NODES[3584].Fix(BODY_FORCE_X); -NODES[3584].Fix(BODY_FORCE_Y); -NODES[3584].Fix(BODY_FORCE_Z); -NODES[3585].Fix(BODY_FORCE_X); -NODES[3585].Fix(BODY_FORCE_Y); -NODES[3585].Fix(BODY_FORCE_Z); -NODES[3586].Fix(BODY_FORCE_X); -NODES[3586].Fix(BODY_FORCE_Y); -NODES[3586].Fix(BODY_FORCE_Z); -NODES[3588].Fix(BODY_FORCE_X); -NODES[3588].Fix(BODY_FORCE_Y); -NODES[3588].Fix(BODY_FORCE_Z); -NODES[3589].Fix(BODY_FORCE_X); -NODES[3589].Fix(BODY_FORCE_Y); -NODES[3589].Fix(BODY_FORCE_Z); -NODES[3590].Fix(BODY_FORCE_X); -NODES[3590].Fix(BODY_FORCE_Y); -NODES[3590].Fix(BODY_FORCE_Z); -NODES[3591].Fix(BODY_FORCE_X); -NODES[3591].Fix(BODY_FORCE_Y); -NODES[3591].Fix(BODY_FORCE_Z); -NODES[3592].Fix(BODY_FORCE_X); -NODES[3592].Fix(BODY_FORCE_Y); -NODES[3592].Fix(BODY_FORCE_Z); -NODES[3593].Fix(BODY_FORCE_X); -NODES[3593].Fix(BODY_FORCE_Y); -NODES[3593].Fix(BODY_FORCE_Z); -NODES[3594].Fix(BODY_FORCE_X); -NODES[3594].Fix(BODY_FORCE_Y); -NODES[3594].Fix(BODY_FORCE_Z); -NODES[3595].Fix(BODY_FORCE_X); -NODES[3595].Fix(BODY_FORCE_Y); -NODES[3595].Fix(BODY_FORCE_Z); -NODES[3596].Fix(BODY_FORCE_X); -NODES[3596].Fix(BODY_FORCE_Y); -NODES[3596].Fix(BODY_FORCE_Z); -NODES[3597].Fix(BODY_FORCE_X); -NODES[3597].Fix(BODY_FORCE_Y); -NODES[3597].Fix(BODY_FORCE_Z); -NODES[3598].Fix(BODY_FORCE_X); -NODES[3598].Fix(BODY_FORCE_Y); -NODES[3598].Fix(BODY_FORCE_Z); -NODES[3599].Fix(BODY_FORCE_X); -NODES[3599].Fix(BODY_FORCE_Y); -NODES[3599].Fix(BODY_FORCE_Z); -NODES[3600].Fix(BODY_FORCE_X); -NODES[3600].Fix(BODY_FORCE_Y); -NODES[3600].Fix(BODY_FORCE_Z); -NODES[3601].Fix(BODY_FORCE_X); -NODES[3601].Fix(BODY_FORCE_Y); -NODES[3601].Fix(BODY_FORCE_Z); -NODES[3602].Fix(BODY_FORCE_X); -NODES[3602].Fix(BODY_FORCE_Y); -NODES[3602].Fix(BODY_FORCE_Z); -NODES[3603].Fix(BODY_FORCE_X); -NODES[3603].Fix(BODY_FORCE_Y); -NODES[3603].Fix(BODY_FORCE_Z); -NODES[3604].Fix(BODY_FORCE_X); -NODES[3604].Fix(BODY_FORCE_Y); -NODES[3604].Fix(BODY_FORCE_Z); -NODES[3605].Fix(BODY_FORCE_X); -NODES[3605].Fix(BODY_FORCE_Y); -NODES[3605].Fix(BODY_FORCE_Z); -NODES[3606].Fix(BODY_FORCE_X); -NODES[3606].Fix(BODY_FORCE_Y); -NODES[3606].Fix(BODY_FORCE_Z); -NODES[3607].Fix(BODY_FORCE_X); -NODES[3607].Fix(BODY_FORCE_Y); -NODES[3607].Fix(BODY_FORCE_Z); -NODES[3608].Fix(BODY_FORCE_X); -NODES[3608].Fix(BODY_FORCE_Y); -NODES[3608].Fix(BODY_FORCE_Z); -NODES[3609].Fix(BODY_FORCE_X); -NODES[3609].Fix(BODY_FORCE_Y); -NODES[3609].Fix(BODY_FORCE_Z); -NODES[3610].Fix(BODY_FORCE_X); -NODES[3610].Fix(BODY_FORCE_Y); -NODES[3610].Fix(BODY_FORCE_Z); -NODES[3611].Fix(BODY_FORCE_X); -NODES[3611].Fix(BODY_FORCE_Y); -NODES[3611].Fix(BODY_FORCE_Z); -NODES[3612].Fix(BODY_FORCE_X); -NODES[3612].Fix(BODY_FORCE_Y); -NODES[3612].Fix(BODY_FORCE_Z); -NODES[3613].Fix(BODY_FORCE_X); -NODES[3613].Fix(BODY_FORCE_Y); -NODES[3613].Fix(BODY_FORCE_Z); -NODES[3614].Fix(BODY_FORCE_X); -NODES[3614].Fix(BODY_FORCE_Y); -NODES[3614].Fix(BODY_FORCE_Z); -NODES[3615].Fix(BODY_FORCE_X); -NODES[3615].Fix(BODY_FORCE_Y); -NODES[3615].Fix(BODY_FORCE_Z); -NODES[3616].Fix(BODY_FORCE_X); -NODES[3616].Fix(BODY_FORCE_Y); -NODES[3616].Fix(BODY_FORCE_Z); -NODES[3618].Fix(BODY_FORCE_X); -NODES[3618].Fix(BODY_FORCE_Y); -NODES[3618].Fix(BODY_FORCE_Z); -NODES[3619].Fix(BODY_FORCE_X); -NODES[3619].Fix(BODY_FORCE_Y); -NODES[3619].Fix(BODY_FORCE_Z); -NODES[3620].Fix(BODY_FORCE_X); -NODES[3620].Fix(BODY_FORCE_Y); -NODES[3620].Fix(BODY_FORCE_Z); -NODES[3621].Fix(BODY_FORCE_X); -NODES[3621].Fix(BODY_FORCE_Y); -NODES[3621].Fix(BODY_FORCE_Z); -NODES[3622].Fix(BODY_FORCE_X); -NODES[3622].Fix(BODY_FORCE_Y); -NODES[3622].Fix(BODY_FORCE_Z); -NODES[3623].Fix(BODY_FORCE_X); -NODES[3623].Fix(BODY_FORCE_Y); -NODES[3623].Fix(BODY_FORCE_Z); -NODES[3624].Fix(BODY_FORCE_X); -NODES[3624].Fix(BODY_FORCE_Y); -NODES[3624].Fix(BODY_FORCE_Z); -NODES[3625].Fix(BODY_FORCE_X); -NODES[3625].Fix(BODY_FORCE_Y); -NODES[3625].Fix(BODY_FORCE_Z); -NODES[3626].Fix(BODY_FORCE_X); -NODES[3626].Fix(BODY_FORCE_Y); -NODES[3626].Fix(BODY_FORCE_Z); -NODES[3627].Fix(BODY_FORCE_X); -NODES[3627].Fix(BODY_FORCE_Y); -NODES[3627].Fix(BODY_FORCE_Z); -NODES[3628].Fix(BODY_FORCE_X); -NODES[3628].Fix(BODY_FORCE_Y); -NODES[3628].Fix(BODY_FORCE_Z); -NODES[3629].Fix(BODY_FORCE_X); -NODES[3629].Fix(BODY_FORCE_Y); -NODES[3629].Fix(BODY_FORCE_Z); -NODES[3630].Fix(BODY_FORCE_X); -NODES[3630].Fix(BODY_FORCE_Y); -NODES[3630].Fix(BODY_FORCE_Z); -NODES[3631].Fix(BODY_FORCE_X); -NODES[3631].Fix(BODY_FORCE_Y); -NODES[3631].Fix(BODY_FORCE_Z); -NODES[3632].Fix(BODY_FORCE_X); -NODES[3632].Fix(BODY_FORCE_Y); -NODES[3632].Fix(BODY_FORCE_Z); -NODES[3633].Fix(BODY_FORCE_X); -NODES[3633].Fix(BODY_FORCE_Y); -NODES[3633].Fix(BODY_FORCE_Z); -NODES[3634].Fix(BODY_FORCE_X); -NODES[3634].Fix(BODY_FORCE_Y); -NODES[3634].Fix(BODY_FORCE_Z); -NODES[3635].Fix(BODY_FORCE_X); -NODES[3635].Fix(BODY_FORCE_Y); -NODES[3635].Fix(BODY_FORCE_Z); -NODES[3636].Fix(BODY_FORCE_X); -NODES[3636].Fix(BODY_FORCE_Y); -NODES[3636].Fix(BODY_FORCE_Z); -NODES[3637].Fix(BODY_FORCE_X); -NODES[3637].Fix(BODY_FORCE_Y); -NODES[3637].Fix(BODY_FORCE_Z); -NODES[3638].Fix(BODY_FORCE_X); -NODES[3638].Fix(BODY_FORCE_Y); -NODES[3638].Fix(BODY_FORCE_Z); -NODES[3639].Fix(BODY_FORCE_X); -NODES[3639].Fix(BODY_FORCE_Y); -NODES[3639].Fix(BODY_FORCE_Z); -NODES[3640].Fix(BODY_FORCE_X); -NODES[3640].Fix(BODY_FORCE_Y); -NODES[3640].Fix(BODY_FORCE_Z); -NODES[3641].Fix(BODY_FORCE_X); -NODES[3641].Fix(BODY_FORCE_Y); -NODES[3641].Fix(BODY_FORCE_Z); -NODES[3642].Fix(BODY_FORCE_X); -NODES[3642].Fix(BODY_FORCE_Y); -NODES[3642].Fix(BODY_FORCE_Z); -NODES[3643].Fix(BODY_FORCE_X); -NODES[3643].Fix(BODY_FORCE_Y); -NODES[3643].Fix(BODY_FORCE_Z); -NODES[3644].Fix(BODY_FORCE_X); -NODES[3644].Fix(BODY_FORCE_Y); -NODES[3644].Fix(BODY_FORCE_Z); -NODES[3645].Fix(BODY_FORCE_X); -NODES[3645].Fix(BODY_FORCE_Y); -NODES[3645].Fix(BODY_FORCE_Z); -NODES[3646].Fix(BODY_FORCE_X); -NODES[3646].Fix(BODY_FORCE_Y); -NODES[3646].Fix(BODY_FORCE_Z); -NODES[3647].Fix(BODY_FORCE_X); -NODES[3647].Fix(BODY_FORCE_Y); -NODES[3647].Fix(BODY_FORCE_Z); -NODES[3652].Fix(BODY_FORCE_X); -NODES[3652].Fix(BODY_FORCE_Y); -NODES[3652].Fix(BODY_FORCE_Z); -NODES[3655].Fix(BODY_FORCE_X); -NODES[3655].Fix(BODY_FORCE_Y); -NODES[3655].Fix(BODY_FORCE_Z); -NODES[3658].Fix(BODY_FORCE_X); -NODES[3658].Fix(BODY_FORCE_Y); -NODES[3658].Fix(BODY_FORCE_Z); -NODES[3660].Fix(BODY_FORCE_X); -NODES[3660].Fix(BODY_FORCE_Y); -NODES[3660].Fix(BODY_FORCE_Z); -NODES[3662].Fix(BODY_FORCE_X); -NODES[3662].Fix(BODY_FORCE_Y); -NODES[3662].Fix(BODY_FORCE_Z); -NODES[3663].Fix(BODY_FORCE_X); -NODES[3663].Fix(BODY_FORCE_Y); -NODES[3663].Fix(BODY_FORCE_Z); -NODES[3666].Fix(BODY_FORCE_X); -NODES[3666].Fix(BODY_FORCE_Y); -NODES[3666].Fix(BODY_FORCE_Z); -NODES[3672].Fix(BODY_FORCE_X); -NODES[3672].Fix(BODY_FORCE_Y); -NODES[3672].Fix(BODY_FORCE_Z); -NODES[3673].Fix(BODY_FORCE_X); -NODES[3673].Fix(BODY_FORCE_Y); -NODES[3673].Fix(BODY_FORCE_Z); -NODES[3674].Fix(BODY_FORCE_X); -NODES[3674].Fix(BODY_FORCE_Y); -NODES[3674].Fix(BODY_FORCE_Z); -NODES[3675].Fix(BODY_FORCE_X); -NODES[3675].Fix(BODY_FORCE_Y); -NODES[3675].Fix(BODY_FORCE_Z); -NODES[3676].Fix(BODY_FORCE_X); -NODES[3676].Fix(BODY_FORCE_Y); -NODES[3676].Fix(BODY_FORCE_Z); -NODES[3677].Fix(BODY_FORCE_X); -NODES[3677].Fix(BODY_FORCE_Y); -NODES[3677].Fix(BODY_FORCE_Z); -NODES[3678].Fix(BODY_FORCE_X); -NODES[3678].Fix(BODY_FORCE_Y); -NODES[3678].Fix(BODY_FORCE_Z); -NODES[3679].Fix(BODY_FORCE_X); -NODES[3679].Fix(BODY_FORCE_Y); -NODES[3679].Fix(BODY_FORCE_Z); -NODES[3680].Fix(BODY_FORCE_X); -NODES[3680].Fix(BODY_FORCE_Y); -NODES[3680].Fix(BODY_FORCE_Z); -NODES[3681].Fix(BODY_FORCE_X); -NODES[3681].Fix(BODY_FORCE_Y); -NODES[3681].Fix(BODY_FORCE_Z); -NODES[3682].Fix(BODY_FORCE_X); -NODES[3682].Fix(BODY_FORCE_Y); -NODES[3682].Fix(BODY_FORCE_Z); -NODES[3684].Fix(BODY_FORCE_X); -NODES[3684].Fix(BODY_FORCE_Y); -NODES[3684].Fix(BODY_FORCE_Z); -NODES[3685].Fix(BODY_FORCE_X); -NODES[3685].Fix(BODY_FORCE_Y); -NODES[3685].Fix(BODY_FORCE_Z); -NODES[3686].Fix(BODY_FORCE_X); -NODES[3686].Fix(BODY_FORCE_Y); -NODES[3686].Fix(BODY_FORCE_Z); -NODES[3687].Fix(BODY_FORCE_X); -NODES[3687].Fix(BODY_FORCE_Y); -NODES[3687].Fix(BODY_FORCE_Z); -NODES[3688].Fix(BODY_FORCE_X); -NODES[3688].Fix(BODY_FORCE_Y); -NODES[3688].Fix(BODY_FORCE_Z); -NODES[3690].Fix(BODY_FORCE_X); -NODES[3690].Fix(BODY_FORCE_Y); -NODES[3690].Fix(BODY_FORCE_Z); -NODES[3691].Fix(BODY_FORCE_X); -NODES[3691].Fix(BODY_FORCE_Y); -NODES[3691].Fix(BODY_FORCE_Z); -NODES[3693].Fix(BODY_FORCE_X); -NODES[3693].Fix(BODY_FORCE_Y); -NODES[3693].Fix(BODY_FORCE_Z); -NODES[3695].Fix(BODY_FORCE_X); -NODES[3695].Fix(BODY_FORCE_Y); -NODES[3695].Fix(BODY_FORCE_Z); -NODES[3696].Fix(BODY_FORCE_X); -NODES[3696].Fix(BODY_FORCE_Y); -NODES[3696].Fix(BODY_FORCE_Z); -NODES[3697].Fix(BODY_FORCE_X); -NODES[3697].Fix(BODY_FORCE_Y); -NODES[3697].Fix(BODY_FORCE_Z); -NODES[3701].Fix(BODY_FORCE_X); -NODES[3701].Fix(BODY_FORCE_Y); -NODES[3701].Fix(BODY_FORCE_Z); -NODES[3702].Fix(BODY_FORCE_X); -NODES[3702].Fix(BODY_FORCE_Y); -NODES[3702].Fix(BODY_FORCE_Z); -NODES[3703].Fix(BODY_FORCE_X); -NODES[3703].Fix(BODY_FORCE_Y); -NODES[3703].Fix(BODY_FORCE_Z); -NODES[3704].Fix(BODY_FORCE_X); -NODES[3704].Fix(BODY_FORCE_Y); -NODES[3704].Fix(BODY_FORCE_Z); -NODES[3706].Fix(BODY_FORCE_X); -NODES[3706].Fix(BODY_FORCE_Y); -NODES[3706].Fix(BODY_FORCE_Z); -NODES[3707].Fix(BODY_FORCE_X); -NODES[3707].Fix(BODY_FORCE_Y); -NODES[3707].Fix(BODY_FORCE_Z); -NODES[3708].Fix(BODY_FORCE_X); -NODES[3708].Fix(BODY_FORCE_Y); -NODES[3708].Fix(BODY_FORCE_Z); -NODES[3709].Fix(BODY_FORCE_X); -NODES[3709].Fix(BODY_FORCE_Y); -NODES[3709].Fix(BODY_FORCE_Z); -NODES[3710].Fix(BODY_FORCE_X); -NODES[3710].Fix(BODY_FORCE_Y); -NODES[3710].Fix(BODY_FORCE_Z); -NODES[3711].Fix(BODY_FORCE_X); -NODES[3711].Fix(BODY_FORCE_Y); -NODES[3711].Fix(BODY_FORCE_Z); -NODES[3712].Fix(BODY_FORCE_X); -NODES[3712].Fix(BODY_FORCE_Y); -NODES[3712].Fix(BODY_FORCE_Z); -NODES[3713].Fix(BODY_FORCE_X); -NODES[3713].Fix(BODY_FORCE_Y); -NODES[3713].Fix(BODY_FORCE_Z); -NODES[3714].Fix(BODY_FORCE_X); -NODES[3714].Fix(BODY_FORCE_Y); -NODES[3714].Fix(BODY_FORCE_Z); -NODES[3715].Fix(BODY_FORCE_X); -NODES[3715].Fix(BODY_FORCE_Y); -NODES[3715].Fix(BODY_FORCE_Z); -NODES[3717].Fix(BODY_FORCE_X); -NODES[3717].Fix(BODY_FORCE_Y); -NODES[3717].Fix(BODY_FORCE_Z); -NODES[3718].Fix(BODY_FORCE_X); -NODES[3718].Fix(BODY_FORCE_Y); -NODES[3718].Fix(BODY_FORCE_Z); -NODES[3719].Fix(BODY_FORCE_X); -NODES[3719].Fix(BODY_FORCE_Y); -NODES[3719].Fix(BODY_FORCE_Z); -NODES[3720].Fix(BODY_FORCE_X); -NODES[3720].Fix(BODY_FORCE_Y); -NODES[3720].Fix(BODY_FORCE_Z); -NODES[3722].Fix(BODY_FORCE_X); -NODES[3722].Fix(BODY_FORCE_Y); -NODES[3722].Fix(BODY_FORCE_Z); -NODES[3723].Fix(BODY_FORCE_X); -NODES[3723].Fix(BODY_FORCE_Y); -NODES[3723].Fix(BODY_FORCE_Z); -NODES[3725].Fix(BODY_FORCE_X); -NODES[3725].Fix(BODY_FORCE_Y); -NODES[3725].Fix(BODY_FORCE_Z); -NODES[3726].Fix(BODY_FORCE_X); -NODES[3726].Fix(BODY_FORCE_Y); -NODES[3726].Fix(BODY_FORCE_Z); -NODES[3728].Fix(BODY_FORCE_X); -NODES[3728].Fix(BODY_FORCE_Y); -NODES[3728].Fix(BODY_FORCE_Z); -NODES[3730].Fix(BODY_FORCE_X); -NODES[3730].Fix(BODY_FORCE_Y); -NODES[3730].Fix(BODY_FORCE_Z); -NODES[3731].Fix(BODY_FORCE_X); -NODES[3731].Fix(BODY_FORCE_Y); -NODES[3731].Fix(BODY_FORCE_Z); -NODES[3732].Fix(BODY_FORCE_X); -NODES[3732].Fix(BODY_FORCE_Y); -NODES[3732].Fix(BODY_FORCE_Z); -NODES[3733].Fix(BODY_FORCE_X); -NODES[3733].Fix(BODY_FORCE_Y); -NODES[3733].Fix(BODY_FORCE_Z); -NODES[3734].Fix(BODY_FORCE_X); -NODES[3734].Fix(BODY_FORCE_Y); -NODES[3734].Fix(BODY_FORCE_Z); -NODES[3736].Fix(BODY_FORCE_X); -NODES[3736].Fix(BODY_FORCE_Y); -NODES[3736].Fix(BODY_FORCE_Z); -NODES[3737].Fix(BODY_FORCE_X); -NODES[3737].Fix(BODY_FORCE_Y); -NODES[3737].Fix(BODY_FORCE_Z); -NODES[3738].Fix(BODY_FORCE_X); -NODES[3738].Fix(BODY_FORCE_Y); -NODES[3738].Fix(BODY_FORCE_Z); -NODES[3739].Fix(BODY_FORCE_X); -NODES[3739].Fix(BODY_FORCE_Y); -NODES[3739].Fix(BODY_FORCE_Z); -NODES[3740].Fix(BODY_FORCE_X); -NODES[3740].Fix(BODY_FORCE_Y); -NODES[3740].Fix(BODY_FORCE_Z); -NODES[3741].Fix(BODY_FORCE_X); -NODES[3741].Fix(BODY_FORCE_Y); -NODES[3741].Fix(BODY_FORCE_Z); -NODES[3742].Fix(BODY_FORCE_X); -NODES[3742].Fix(BODY_FORCE_Y); -NODES[3742].Fix(BODY_FORCE_Z); -NODES[3743].Fix(BODY_FORCE_X); -NODES[3743].Fix(BODY_FORCE_Y); -NODES[3743].Fix(BODY_FORCE_Z); -NODES[3744].Fix(BODY_FORCE_X); -NODES[3744].Fix(BODY_FORCE_Y); -NODES[3744].Fix(BODY_FORCE_Z); -NODES[3746].Fix(BODY_FORCE_X); -NODES[3746].Fix(BODY_FORCE_Y); -NODES[3746].Fix(BODY_FORCE_Z); -NODES[3747].Fix(BODY_FORCE_X); -NODES[3747].Fix(BODY_FORCE_Y); -NODES[3747].Fix(BODY_FORCE_Z); -NODES[3748].Fix(BODY_FORCE_X); -NODES[3748].Fix(BODY_FORCE_Y); -NODES[3748].Fix(BODY_FORCE_Z); -NODES[3749].Fix(BODY_FORCE_X); -NODES[3749].Fix(BODY_FORCE_Y); -NODES[3749].Fix(BODY_FORCE_Z); -NODES[3751].Fix(BODY_FORCE_X); -NODES[3751].Fix(BODY_FORCE_Y); -NODES[3751].Fix(BODY_FORCE_Z); -NODES[3752].Fix(BODY_FORCE_X); -NODES[3752].Fix(BODY_FORCE_Y); -NODES[3752].Fix(BODY_FORCE_Z); -NODES[3753].Fix(BODY_FORCE_X); -NODES[3753].Fix(BODY_FORCE_Y); -NODES[3753].Fix(BODY_FORCE_Z); -NODES[3756].Fix(BODY_FORCE_X); -NODES[3756].Fix(BODY_FORCE_Y); -NODES[3756].Fix(BODY_FORCE_Z); -NODES[3757].Fix(BODY_FORCE_X); -NODES[3757].Fix(BODY_FORCE_Y); -NODES[3757].Fix(BODY_FORCE_Z); -NODES[3758].Fix(BODY_FORCE_X); -NODES[3758].Fix(BODY_FORCE_Y); -NODES[3758].Fix(BODY_FORCE_Z); -NODES[3759].Fix(BODY_FORCE_X); -NODES[3759].Fix(BODY_FORCE_Y); -NODES[3759].Fix(BODY_FORCE_Z); -NODES[3760].Fix(BODY_FORCE_X); -NODES[3760].Fix(BODY_FORCE_Y); -NODES[3760].Fix(BODY_FORCE_Z); -NODES[3761].Fix(BODY_FORCE_X); -NODES[3761].Fix(BODY_FORCE_Y); -NODES[3761].Fix(BODY_FORCE_Z); -NODES[3762].Fix(BODY_FORCE_X); -NODES[3762].Fix(BODY_FORCE_Y); -NODES[3762].Fix(BODY_FORCE_Z); -NODES[3763].Fix(BODY_FORCE_X); -NODES[3763].Fix(BODY_FORCE_Y); -NODES[3763].Fix(BODY_FORCE_Z); -NODES[3764].Fix(BODY_FORCE_X); -NODES[3764].Fix(BODY_FORCE_Y); -NODES[3764].Fix(BODY_FORCE_Z); -NODES[3766].Fix(BODY_FORCE_X); -NODES[3766].Fix(BODY_FORCE_Y); -NODES[3766].Fix(BODY_FORCE_Z); -NODES[3767].Fix(BODY_FORCE_X); -NODES[3767].Fix(BODY_FORCE_Y); -NODES[3767].Fix(BODY_FORCE_Z); -NODES[3768].Fix(BODY_FORCE_X); -NODES[3768].Fix(BODY_FORCE_Y); -NODES[3768].Fix(BODY_FORCE_Z); -NODES[3769].Fix(BODY_FORCE_X); -NODES[3769].Fix(BODY_FORCE_Y); -NODES[3769].Fix(BODY_FORCE_Z); -NODES[3770].Fix(BODY_FORCE_X); -NODES[3770].Fix(BODY_FORCE_Y); -NODES[3770].Fix(BODY_FORCE_Z); -NODES[3771].Fix(BODY_FORCE_X); -NODES[3771].Fix(BODY_FORCE_Y); -NODES[3771].Fix(BODY_FORCE_Z); -NODES[3772].Fix(BODY_FORCE_X); -NODES[3772].Fix(BODY_FORCE_Y); -NODES[3772].Fix(BODY_FORCE_Z); -NODES[3773].Fix(BODY_FORCE_X); -NODES[3773].Fix(BODY_FORCE_Y); -NODES[3773].Fix(BODY_FORCE_Z); -NODES[3775].Fix(BODY_FORCE_X); -NODES[3775].Fix(BODY_FORCE_Y); -NODES[3775].Fix(BODY_FORCE_Z); -NODES[3776].Fix(BODY_FORCE_X); -NODES[3776].Fix(BODY_FORCE_Y); -NODES[3776].Fix(BODY_FORCE_Z); -NODES[3777].Fix(BODY_FORCE_X); -NODES[3777].Fix(BODY_FORCE_Y); -NODES[3777].Fix(BODY_FORCE_Z); -NODES[3779].Fix(BODY_FORCE_X); -NODES[3779].Fix(BODY_FORCE_Y); -NODES[3779].Fix(BODY_FORCE_Z); -NODES[3780].Fix(BODY_FORCE_X); -NODES[3780].Fix(BODY_FORCE_Y); -NODES[3780].Fix(BODY_FORCE_Z); -NODES[3781].Fix(BODY_FORCE_X); -NODES[3781].Fix(BODY_FORCE_Y); -NODES[3781].Fix(BODY_FORCE_Z); -NODES[3784].Fix(BODY_FORCE_X); -NODES[3784].Fix(BODY_FORCE_Y); -NODES[3784].Fix(BODY_FORCE_Z); -NODES[3785].Fix(BODY_FORCE_X); -NODES[3785].Fix(BODY_FORCE_Y); -NODES[3785].Fix(BODY_FORCE_Z); -NODES[3786].Fix(BODY_FORCE_X); -NODES[3786].Fix(BODY_FORCE_Y); -NODES[3786].Fix(BODY_FORCE_Z); -NODES[3787].Fix(BODY_FORCE_X); -NODES[3787].Fix(BODY_FORCE_Y); -NODES[3787].Fix(BODY_FORCE_Z); -NODES[3788].Fix(BODY_FORCE_X); -NODES[3788].Fix(BODY_FORCE_Y); -NODES[3788].Fix(BODY_FORCE_Z); -NODES[3789].Fix(BODY_FORCE_X); -NODES[3789].Fix(BODY_FORCE_Y); -NODES[3789].Fix(BODY_FORCE_Z); -NODES[3790].Fix(BODY_FORCE_X); -NODES[3790].Fix(BODY_FORCE_Y); -NODES[3790].Fix(BODY_FORCE_Z); -NODES[3791].Fix(BODY_FORCE_X); -NODES[3791].Fix(BODY_FORCE_Y); -NODES[3791].Fix(BODY_FORCE_Z); -NODES[3792].Fix(BODY_FORCE_X); -NODES[3792].Fix(BODY_FORCE_Y); -NODES[3792].Fix(BODY_FORCE_Z); -NODES[3793].Fix(BODY_FORCE_X); -NODES[3793].Fix(BODY_FORCE_Y); -NODES[3793].Fix(BODY_FORCE_Z); -NODES[3794].Fix(BODY_FORCE_X); -NODES[3794].Fix(BODY_FORCE_Y); -NODES[3794].Fix(BODY_FORCE_Z); -NODES[3795].Fix(BODY_FORCE_X); -NODES[3795].Fix(BODY_FORCE_Y); -NODES[3795].Fix(BODY_FORCE_Z); -NODES[3796].Fix(BODY_FORCE_X); -NODES[3796].Fix(BODY_FORCE_Y); -NODES[3796].Fix(BODY_FORCE_Z); -NODES[3797].Fix(BODY_FORCE_X); -NODES[3797].Fix(BODY_FORCE_Y); -NODES[3797].Fix(BODY_FORCE_Z); -NODES[3798].Fix(BODY_FORCE_X); -NODES[3798].Fix(BODY_FORCE_Y); -NODES[3798].Fix(BODY_FORCE_Z); -NODES[3800].Fix(BODY_FORCE_X); -NODES[3800].Fix(BODY_FORCE_Y); -NODES[3800].Fix(BODY_FORCE_Z); -NODES[3801].Fix(BODY_FORCE_X); -NODES[3801].Fix(BODY_FORCE_Y); -NODES[3801].Fix(BODY_FORCE_Z); -NODES[3802].Fix(BODY_FORCE_X); -NODES[3802].Fix(BODY_FORCE_Y); -NODES[3802].Fix(BODY_FORCE_Z); -NODES[3803].Fix(BODY_FORCE_X); -NODES[3803].Fix(BODY_FORCE_Y); -NODES[3803].Fix(BODY_FORCE_Z); -NODES[3804].Fix(BODY_FORCE_X); -NODES[3804].Fix(BODY_FORCE_Y); -NODES[3804].Fix(BODY_FORCE_Z); -NODES[3806].Fix(BODY_FORCE_X); -NODES[3806].Fix(BODY_FORCE_Y); -NODES[3806].Fix(BODY_FORCE_Z); -NODES[3808].Fix(BODY_FORCE_X); -NODES[3808].Fix(BODY_FORCE_Y); -NODES[3808].Fix(BODY_FORCE_Z); -NODES[3809].Fix(BODY_FORCE_X); -NODES[3809].Fix(BODY_FORCE_Y); -NODES[3809].Fix(BODY_FORCE_Z); -NODES[3811].Fix(BODY_FORCE_X); -NODES[3811].Fix(BODY_FORCE_Y); -NODES[3811].Fix(BODY_FORCE_Z); -NODES[3812].Fix(BODY_FORCE_X); -NODES[3812].Fix(BODY_FORCE_Y); -NODES[3812].Fix(BODY_FORCE_Z); -NODES[3813].Fix(BODY_FORCE_X); -NODES[3813].Fix(BODY_FORCE_Y); -NODES[3813].Fix(BODY_FORCE_Z); -NODES[3814].Fix(BODY_FORCE_X); -NODES[3814].Fix(BODY_FORCE_Y); -NODES[3814].Fix(BODY_FORCE_Z); -NODES[3815].Fix(BODY_FORCE_X); -NODES[3815].Fix(BODY_FORCE_Y); -NODES[3815].Fix(BODY_FORCE_Z); -NODES[3816].Fix(BODY_FORCE_X); -NODES[3816].Fix(BODY_FORCE_Y); -NODES[3816].Fix(BODY_FORCE_Z); -NODES[3817].Fix(BODY_FORCE_X); -NODES[3817].Fix(BODY_FORCE_Y); -NODES[3817].Fix(BODY_FORCE_Z); -NODES[3818].Fix(BODY_FORCE_X); -NODES[3818].Fix(BODY_FORCE_Y); -NODES[3818].Fix(BODY_FORCE_Z); -NODES[3819].Fix(BODY_FORCE_X); -NODES[3819].Fix(BODY_FORCE_Y); -NODES[3819].Fix(BODY_FORCE_Z); -NODES[3820].Fix(BODY_FORCE_X); -NODES[3820].Fix(BODY_FORCE_Y); -NODES[3820].Fix(BODY_FORCE_Z); -NODES[3821].Fix(BODY_FORCE_X); -NODES[3821].Fix(BODY_FORCE_Y); -NODES[3821].Fix(BODY_FORCE_Z); -NODES[3822].Fix(BODY_FORCE_X); -NODES[3822].Fix(BODY_FORCE_Y); -NODES[3822].Fix(BODY_FORCE_Z); -NODES[3823].Fix(BODY_FORCE_X); -NODES[3823].Fix(BODY_FORCE_Y); -NODES[3823].Fix(BODY_FORCE_Z); -NODES[3825].Fix(BODY_FORCE_X); -NODES[3825].Fix(BODY_FORCE_Y); -NODES[3825].Fix(BODY_FORCE_Z); -NODES[3826].Fix(BODY_FORCE_X); -NODES[3826].Fix(BODY_FORCE_Y); -NODES[3826].Fix(BODY_FORCE_Z); -NODES[3827].Fix(BODY_FORCE_X); -NODES[3827].Fix(BODY_FORCE_Y); -NODES[3827].Fix(BODY_FORCE_Z); -NODES[3828].Fix(BODY_FORCE_X); -NODES[3828].Fix(BODY_FORCE_Y); -NODES[3828].Fix(BODY_FORCE_Z); -NODES[3829].Fix(BODY_FORCE_X); -NODES[3829].Fix(BODY_FORCE_Y); -NODES[3829].Fix(BODY_FORCE_Z); -NODES[3830].Fix(BODY_FORCE_X); -NODES[3830].Fix(BODY_FORCE_Y); -NODES[3830].Fix(BODY_FORCE_Z); -NODES[3832].Fix(BODY_FORCE_X); -NODES[3832].Fix(BODY_FORCE_Y); -NODES[3832].Fix(BODY_FORCE_Z); -NODES[3834].Fix(BODY_FORCE_X); -NODES[3834].Fix(BODY_FORCE_Y); -NODES[3834].Fix(BODY_FORCE_Z); -NODES[3835].Fix(BODY_FORCE_X); -NODES[3835].Fix(BODY_FORCE_Y); -NODES[3835].Fix(BODY_FORCE_Z); -NODES[3836].Fix(BODY_FORCE_X); -NODES[3836].Fix(BODY_FORCE_Y); -NODES[3836].Fix(BODY_FORCE_Z); -NODES[3837].Fix(BODY_FORCE_X); -NODES[3837].Fix(BODY_FORCE_Y); -NODES[3837].Fix(BODY_FORCE_Z); -NODES[3838].Fix(BODY_FORCE_X); -NODES[3838].Fix(BODY_FORCE_Y); -NODES[3838].Fix(BODY_FORCE_Z); -NODES[3839].Fix(BODY_FORCE_X); -NODES[3839].Fix(BODY_FORCE_Y); -NODES[3839].Fix(BODY_FORCE_Z); -NODES[3840].Fix(BODY_FORCE_X); -NODES[3840].Fix(BODY_FORCE_Y); -NODES[3840].Fix(BODY_FORCE_Z); -NODES[3841].Fix(BODY_FORCE_X); -NODES[3841].Fix(BODY_FORCE_Y); -NODES[3841].Fix(BODY_FORCE_Z); -NODES[3842].Fix(BODY_FORCE_X); -NODES[3842].Fix(BODY_FORCE_Y); -NODES[3842].Fix(BODY_FORCE_Z); -NODES[3844].Fix(BODY_FORCE_X); -NODES[3844].Fix(BODY_FORCE_Y); -NODES[3844].Fix(BODY_FORCE_Z); -NODES[3845].Fix(BODY_FORCE_X); -NODES[3845].Fix(BODY_FORCE_Y); -NODES[3845].Fix(BODY_FORCE_Z); -NODES[3846].Fix(BODY_FORCE_X); -NODES[3846].Fix(BODY_FORCE_Y); -NODES[3846].Fix(BODY_FORCE_Z); -NODES[3847].Fix(BODY_FORCE_X); -NODES[3847].Fix(BODY_FORCE_Y); -NODES[3847].Fix(BODY_FORCE_Z); -NODES[3848].Fix(BODY_FORCE_X); -NODES[3848].Fix(BODY_FORCE_Y); -NODES[3848].Fix(BODY_FORCE_Z); -NODES[3849].Fix(BODY_FORCE_X); -NODES[3849].Fix(BODY_FORCE_Y); -NODES[3849].Fix(BODY_FORCE_Z); -NODES[3850].Fix(BODY_FORCE_X); -NODES[3850].Fix(BODY_FORCE_Y); -NODES[3850].Fix(BODY_FORCE_Z); -NODES[3851].Fix(BODY_FORCE_X); -NODES[3851].Fix(BODY_FORCE_Y); -NODES[3851].Fix(BODY_FORCE_Z); -NODES[3853].Fix(BODY_FORCE_X); -NODES[3853].Fix(BODY_FORCE_Y); -NODES[3853].Fix(BODY_FORCE_Z); -NODES[3854].Fix(BODY_FORCE_X); -NODES[3854].Fix(BODY_FORCE_Y); -NODES[3854].Fix(BODY_FORCE_Z); -NODES[3855].Fix(BODY_FORCE_X); -NODES[3855].Fix(BODY_FORCE_Y); -NODES[3855].Fix(BODY_FORCE_Z); -NODES[3856].Fix(BODY_FORCE_X); -NODES[3856].Fix(BODY_FORCE_Y); -NODES[3856].Fix(BODY_FORCE_Z); -NODES[3858].Fix(BODY_FORCE_X); -NODES[3858].Fix(BODY_FORCE_Y); -NODES[3858].Fix(BODY_FORCE_Z); -NODES[3859].Fix(BODY_FORCE_X); -NODES[3859].Fix(BODY_FORCE_Y); -NODES[3859].Fix(BODY_FORCE_Z); -NODES[3860].Fix(BODY_FORCE_X); -NODES[3860].Fix(BODY_FORCE_Y); -NODES[3860].Fix(BODY_FORCE_Z); -NODES[3861].Fix(BODY_FORCE_X); -NODES[3861].Fix(BODY_FORCE_Y); -NODES[3861].Fix(BODY_FORCE_Z); -NODES[3863].Fix(BODY_FORCE_X); -NODES[3863].Fix(BODY_FORCE_Y); -NODES[3863].Fix(BODY_FORCE_Z); -NODES[3864].Fix(BODY_FORCE_X); -NODES[3864].Fix(BODY_FORCE_Y); -NODES[3864].Fix(BODY_FORCE_Z); -NODES[3865].Fix(BODY_FORCE_X); -NODES[3865].Fix(BODY_FORCE_Y); -NODES[3865].Fix(BODY_FORCE_Z); -NODES[3866].Fix(BODY_FORCE_X); -NODES[3866].Fix(BODY_FORCE_Y); -NODES[3866].Fix(BODY_FORCE_Z); -NODES[3867].Fix(BODY_FORCE_X); -NODES[3867].Fix(BODY_FORCE_Y); -NODES[3867].Fix(BODY_FORCE_Z); -NODES[3868].Fix(BODY_FORCE_X); -NODES[3868].Fix(BODY_FORCE_Y); -NODES[3868].Fix(BODY_FORCE_Z); -NODES[3869].Fix(BODY_FORCE_X); -NODES[3869].Fix(BODY_FORCE_Y); -NODES[3869].Fix(BODY_FORCE_Z); -NODES[3870].Fix(BODY_FORCE_X); -NODES[3870].Fix(BODY_FORCE_Y); -NODES[3870].Fix(BODY_FORCE_Z); -NODES[3871].Fix(BODY_FORCE_X); -NODES[3871].Fix(BODY_FORCE_Y); -NODES[3871].Fix(BODY_FORCE_Z); -NODES[3872].Fix(BODY_FORCE_X); -NODES[3872].Fix(BODY_FORCE_Y); -NODES[3872].Fix(BODY_FORCE_Z); -NODES[3873].Fix(BODY_FORCE_X); -NODES[3873].Fix(BODY_FORCE_Y); -NODES[3873].Fix(BODY_FORCE_Z); -NODES[3874].Fix(BODY_FORCE_X); -NODES[3874].Fix(BODY_FORCE_Y); -NODES[3874].Fix(BODY_FORCE_Z); -NODES[3876].Fix(BODY_FORCE_X); -NODES[3876].Fix(BODY_FORCE_Y); -NODES[3876].Fix(BODY_FORCE_Z); -NODES[3877].Fix(BODY_FORCE_X); -NODES[3877].Fix(BODY_FORCE_Y); -NODES[3877].Fix(BODY_FORCE_Z); -NODES[3878].Fix(BODY_FORCE_X); -NODES[3878].Fix(BODY_FORCE_Y); -NODES[3878].Fix(BODY_FORCE_Z); -NODES[3880].Fix(BODY_FORCE_X); -NODES[3880].Fix(BODY_FORCE_Y); -NODES[3880].Fix(BODY_FORCE_Z); -NODES[3881].Fix(BODY_FORCE_X); -NODES[3881].Fix(BODY_FORCE_Y); -NODES[3881].Fix(BODY_FORCE_Z); -NODES[3882].Fix(BODY_FORCE_X); -NODES[3882].Fix(BODY_FORCE_Y); -NODES[3882].Fix(BODY_FORCE_Z); -NODES[3883].Fix(BODY_FORCE_X); -NODES[3883].Fix(BODY_FORCE_Y); -NODES[3883].Fix(BODY_FORCE_Z); -NODES[3884].Fix(BODY_FORCE_X); -NODES[3884].Fix(BODY_FORCE_Y); -NODES[3884].Fix(BODY_FORCE_Z); -NODES[3885].Fix(BODY_FORCE_X); -NODES[3885].Fix(BODY_FORCE_Y); -NODES[3885].Fix(BODY_FORCE_Z); -NODES[3886].Fix(BODY_FORCE_X); -NODES[3886].Fix(BODY_FORCE_Y); -NODES[3886].Fix(BODY_FORCE_Z); -NODES[3887].Fix(BODY_FORCE_X); -NODES[3887].Fix(BODY_FORCE_Y); -NODES[3887].Fix(BODY_FORCE_Z); -NODES[3889].Fix(BODY_FORCE_X); -NODES[3889].Fix(BODY_FORCE_Y); -NODES[3889].Fix(BODY_FORCE_Z); -NODES[3890].Fix(BODY_FORCE_X); -NODES[3890].Fix(BODY_FORCE_Y); -NODES[3890].Fix(BODY_FORCE_Z); -NODES[3891].Fix(BODY_FORCE_X); -NODES[3891].Fix(BODY_FORCE_Y); -NODES[3891].Fix(BODY_FORCE_Z); -NODES[3892].Fix(BODY_FORCE_X); -NODES[3892].Fix(BODY_FORCE_Y); -NODES[3892].Fix(BODY_FORCE_Z); -NODES[3893].Fix(BODY_FORCE_X); -NODES[3893].Fix(BODY_FORCE_Y); -NODES[3893].Fix(BODY_FORCE_Z); -NODES[3894].Fix(BODY_FORCE_X); -NODES[3894].Fix(BODY_FORCE_Y); -NODES[3894].Fix(BODY_FORCE_Z); -NODES[3895].Fix(BODY_FORCE_X); -NODES[3895].Fix(BODY_FORCE_Y); -NODES[3895].Fix(BODY_FORCE_Z); -NODES[3896].Fix(BODY_FORCE_X); -NODES[3896].Fix(BODY_FORCE_Y); -NODES[3896].Fix(BODY_FORCE_Z); -NODES[3897].Fix(BODY_FORCE_X); -NODES[3897].Fix(BODY_FORCE_Y); -NODES[3897].Fix(BODY_FORCE_Z); -NODES[3898].Fix(BODY_FORCE_X); -NODES[3898].Fix(BODY_FORCE_Y); -NODES[3898].Fix(BODY_FORCE_Z); -NODES[3899].Fix(BODY_FORCE_X); -NODES[3899].Fix(BODY_FORCE_Y); -NODES[3899].Fix(BODY_FORCE_Z); -NODES[3901].Fix(BODY_FORCE_X); -NODES[3901].Fix(BODY_FORCE_Y); -NODES[3901].Fix(BODY_FORCE_Z); -NODES[3902].Fix(BODY_FORCE_X); -NODES[3902].Fix(BODY_FORCE_Y); -NODES[3902].Fix(BODY_FORCE_Z); -NODES[3903].Fix(BODY_FORCE_X); -NODES[3903].Fix(BODY_FORCE_Y); -NODES[3903].Fix(BODY_FORCE_Z); -NODES[3904].Fix(BODY_FORCE_X); -NODES[3904].Fix(BODY_FORCE_Y); -NODES[3904].Fix(BODY_FORCE_Z); -NODES[3906].Fix(BODY_FORCE_X); -NODES[3906].Fix(BODY_FORCE_Y); -NODES[3906].Fix(BODY_FORCE_Z); -NODES[3907].Fix(BODY_FORCE_X); -NODES[3907].Fix(BODY_FORCE_Y); -NODES[3907].Fix(BODY_FORCE_Z); -NODES[3908].Fix(BODY_FORCE_X); -NODES[3908].Fix(BODY_FORCE_Y); -NODES[3908].Fix(BODY_FORCE_Z); -NODES[3909].Fix(BODY_FORCE_X); -NODES[3909].Fix(BODY_FORCE_Y); -NODES[3909].Fix(BODY_FORCE_Z); -NODES[3910].Fix(BODY_FORCE_X); -NODES[3910].Fix(BODY_FORCE_Y); -NODES[3910].Fix(BODY_FORCE_Z); -NODES[3911].Fix(BODY_FORCE_X); -NODES[3911].Fix(BODY_FORCE_Y); -NODES[3911].Fix(BODY_FORCE_Z); -NODES[3913].Fix(BODY_FORCE_X); -NODES[3913].Fix(BODY_FORCE_Y); -NODES[3913].Fix(BODY_FORCE_Z); -NODES[3914].Fix(BODY_FORCE_X); -NODES[3914].Fix(BODY_FORCE_Y); -NODES[3914].Fix(BODY_FORCE_Z); -NODES[3915].Fix(BODY_FORCE_X); -NODES[3915].Fix(BODY_FORCE_Y); -NODES[3915].Fix(BODY_FORCE_Z); -NODES[3916].Fix(BODY_FORCE_X); -NODES[3916].Fix(BODY_FORCE_Y); -NODES[3916].Fix(BODY_FORCE_Z); -NODES[3917].Fix(BODY_FORCE_X); -NODES[3917].Fix(BODY_FORCE_Y); -NODES[3917].Fix(BODY_FORCE_Z); -NODES[3918].Fix(BODY_FORCE_X); -NODES[3918].Fix(BODY_FORCE_Y); -NODES[3918].Fix(BODY_FORCE_Z); -NODES[3919].Fix(BODY_FORCE_X); -NODES[3919].Fix(BODY_FORCE_Y); -NODES[3919].Fix(BODY_FORCE_Z); -NODES[3920].Fix(BODY_FORCE_X); -NODES[3920].Fix(BODY_FORCE_Y); -NODES[3920].Fix(BODY_FORCE_Z); -NODES[3921].Fix(BODY_FORCE_X); -NODES[3921].Fix(BODY_FORCE_Y); -NODES[3921].Fix(BODY_FORCE_Z); -NODES[3922].Fix(BODY_FORCE_X); -NODES[3922].Fix(BODY_FORCE_Y); -NODES[3922].Fix(BODY_FORCE_Z); -NODES[3924].Fix(BODY_FORCE_X); -NODES[3924].Fix(BODY_FORCE_Y); -NODES[3924].Fix(BODY_FORCE_Z); -NODES[3925].Fix(BODY_FORCE_X); -NODES[3925].Fix(BODY_FORCE_Y); -NODES[3925].Fix(BODY_FORCE_Z); -NODES[3926].Fix(BODY_FORCE_X); -NODES[3926].Fix(BODY_FORCE_Y); -NODES[3926].Fix(BODY_FORCE_Z); -NODES[3927].Fix(BODY_FORCE_X); -NODES[3927].Fix(BODY_FORCE_Y); -NODES[3927].Fix(BODY_FORCE_Z); -NODES[3928].Fix(BODY_FORCE_X); -NODES[3928].Fix(BODY_FORCE_Y); -NODES[3928].Fix(BODY_FORCE_Z); -NODES[3929].Fix(BODY_FORCE_X); -NODES[3929].Fix(BODY_FORCE_Y); -NODES[3929].Fix(BODY_FORCE_Z); -NODES[3930].Fix(BODY_FORCE_X); -NODES[3930].Fix(BODY_FORCE_Y); -NODES[3930].Fix(BODY_FORCE_Z); -NODES[3932].Fix(BODY_FORCE_X); -NODES[3932].Fix(BODY_FORCE_Y); -NODES[3932].Fix(BODY_FORCE_Z); -NODES[3933].Fix(BODY_FORCE_X); -NODES[3933].Fix(BODY_FORCE_Y); -NODES[3933].Fix(BODY_FORCE_Z); -NODES[3934].Fix(BODY_FORCE_X); -NODES[3934].Fix(BODY_FORCE_Y); -NODES[3934].Fix(BODY_FORCE_Z); -NODES[3935].Fix(BODY_FORCE_X); -NODES[3935].Fix(BODY_FORCE_Y); -NODES[3935].Fix(BODY_FORCE_Z); -NODES[3936].Fix(BODY_FORCE_X); -NODES[3936].Fix(BODY_FORCE_Y); -NODES[3936].Fix(BODY_FORCE_Z); -NODES[3937].Fix(BODY_FORCE_X); -NODES[3937].Fix(BODY_FORCE_Y); -NODES[3937].Fix(BODY_FORCE_Z); -NODES[3938].Fix(BODY_FORCE_X); -NODES[3938].Fix(BODY_FORCE_Y); -NODES[3938].Fix(BODY_FORCE_Z); -NODES[3940].Fix(BODY_FORCE_X); -NODES[3940].Fix(BODY_FORCE_Y); -NODES[3940].Fix(BODY_FORCE_Z); -NODES[3941].Fix(BODY_FORCE_X); -NODES[3941].Fix(BODY_FORCE_Y); -NODES[3941].Fix(BODY_FORCE_Z); -NODES[3942].Fix(BODY_FORCE_X); -NODES[3942].Fix(BODY_FORCE_Y); -NODES[3942].Fix(BODY_FORCE_Z); -NODES[3943].Fix(BODY_FORCE_X); -NODES[3943].Fix(BODY_FORCE_Y); -NODES[3943].Fix(BODY_FORCE_Z); -NODES[3944].Fix(BODY_FORCE_X); -NODES[3944].Fix(BODY_FORCE_Y); -NODES[3944].Fix(BODY_FORCE_Z); -NODES[3945].Fix(BODY_FORCE_X); -NODES[3945].Fix(BODY_FORCE_Y); -NODES[3945].Fix(BODY_FORCE_Z); -NODES[3946].Fix(BODY_FORCE_X); -NODES[3946].Fix(BODY_FORCE_Y); -NODES[3946].Fix(BODY_FORCE_Z); -NODES[3947].Fix(BODY_FORCE_X); -NODES[3947].Fix(BODY_FORCE_Y); -NODES[3947].Fix(BODY_FORCE_Z); -NODES[3948].Fix(BODY_FORCE_X); -NODES[3948].Fix(BODY_FORCE_Y); -NODES[3948].Fix(BODY_FORCE_Z); -NODES[3949].Fix(BODY_FORCE_X); -NODES[3949].Fix(BODY_FORCE_Y); -NODES[3949].Fix(BODY_FORCE_Z); -NODES[3951].Fix(BODY_FORCE_X); -NODES[3951].Fix(BODY_FORCE_Y); -NODES[3951].Fix(BODY_FORCE_Z); -NODES[3952].Fix(BODY_FORCE_X); -NODES[3952].Fix(BODY_FORCE_Y); -NODES[3952].Fix(BODY_FORCE_Z); -NODES[3953].Fix(BODY_FORCE_X); -NODES[3953].Fix(BODY_FORCE_Y); -NODES[3953].Fix(BODY_FORCE_Z); -NODES[3954].Fix(BODY_FORCE_X); -NODES[3954].Fix(BODY_FORCE_Y); -NODES[3954].Fix(BODY_FORCE_Z); -NODES[3955].Fix(BODY_FORCE_X); -NODES[3955].Fix(BODY_FORCE_Y); -NODES[3955].Fix(BODY_FORCE_Z); -NODES[3956].Fix(BODY_FORCE_X); -NODES[3956].Fix(BODY_FORCE_Y); -NODES[3956].Fix(BODY_FORCE_Z); -NODES[3958].Fix(BODY_FORCE_X); -NODES[3958].Fix(BODY_FORCE_Y); -NODES[3958].Fix(BODY_FORCE_Z); -NODES[3959].Fix(BODY_FORCE_X); -NODES[3959].Fix(BODY_FORCE_Y); -NODES[3959].Fix(BODY_FORCE_Z); -NODES[3960].Fix(BODY_FORCE_X); -NODES[3960].Fix(BODY_FORCE_Y); -NODES[3960].Fix(BODY_FORCE_Z); -NODES[3961].Fix(BODY_FORCE_X); -NODES[3961].Fix(BODY_FORCE_Y); -NODES[3961].Fix(BODY_FORCE_Z); -NODES[3962].Fix(BODY_FORCE_X); -NODES[3962].Fix(BODY_FORCE_Y); -NODES[3962].Fix(BODY_FORCE_Z); -NODES[3963].Fix(BODY_FORCE_X); -NODES[3963].Fix(BODY_FORCE_Y); -NODES[3963].Fix(BODY_FORCE_Z); -NODES[3964].Fix(BODY_FORCE_X); -NODES[3964].Fix(BODY_FORCE_Y); -NODES[3964].Fix(BODY_FORCE_Z); -NODES[3966].Fix(BODY_FORCE_X); -NODES[3966].Fix(BODY_FORCE_Y); -NODES[3966].Fix(BODY_FORCE_Z); -NODES[3967].Fix(BODY_FORCE_X); -NODES[3967].Fix(BODY_FORCE_Y); -NODES[3967].Fix(BODY_FORCE_Z); -NODES[3968].Fix(BODY_FORCE_X); -NODES[3968].Fix(BODY_FORCE_Y); -NODES[3968].Fix(BODY_FORCE_Z); -NODES[3969].Fix(BODY_FORCE_X); -NODES[3969].Fix(BODY_FORCE_Y); -NODES[3969].Fix(BODY_FORCE_Z); -NODES[3970].Fix(BODY_FORCE_X); -NODES[3970].Fix(BODY_FORCE_Y); -NODES[3970].Fix(BODY_FORCE_Z); -NODES[3971].Fix(BODY_FORCE_X); -NODES[3971].Fix(BODY_FORCE_Y); -NODES[3971].Fix(BODY_FORCE_Z); -NODES[3972].Fix(BODY_FORCE_X); -NODES[3972].Fix(BODY_FORCE_Y); -NODES[3972].Fix(BODY_FORCE_Z); -NODES[3973].Fix(BODY_FORCE_X); -NODES[3973].Fix(BODY_FORCE_Y); -NODES[3973].Fix(BODY_FORCE_Z); -NODES[3974].Fix(BODY_FORCE_X); -NODES[3974].Fix(BODY_FORCE_Y); -NODES[3974].Fix(BODY_FORCE_Z); -NODES[3975].Fix(BODY_FORCE_X); -NODES[3975].Fix(BODY_FORCE_Y); -NODES[3975].Fix(BODY_FORCE_Z); -NODES[3977].Fix(BODY_FORCE_X); -NODES[3977].Fix(BODY_FORCE_Y); -NODES[3977].Fix(BODY_FORCE_Z); -NODES[3978].Fix(BODY_FORCE_X); -NODES[3978].Fix(BODY_FORCE_Y); -NODES[3978].Fix(BODY_FORCE_Z); -NODES[3979].Fix(BODY_FORCE_X); -NODES[3979].Fix(BODY_FORCE_Y); -NODES[3979].Fix(BODY_FORCE_Z); -NODES[3980].Fix(BODY_FORCE_X); -NODES[3980].Fix(BODY_FORCE_Y); -NODES[3980].Fix(BODY_FORCE_Z); -NODES[3981].Fix(BODY_FORCE_X); -NODES[3981].Fix(BODY_FORCE_Y); -NODES[3981].Fix(BODY_FORCE_Z); -NODES[3982].Fix(BODY_FORCE_X); -NODES[3982].Fix(BODY_FORCE_Y); -NODES[3982].Fix(BODY_FORCE_Z); -NODES[3983].Fix(BODY_FORCE_X); -NODES[3983].Fix(BODY_FORCE_Y); -NODES[3983].Fix(BODY_FORCE_Z); -NODES[3984].Fix(BODY_FORCE_X); -NODES[3984].Fix(BODY_FORCE_Y); -NODES[3984].Fix(BODY_FORCE_Z); -NODES[3985].Fix(BODY_FORCE_X); -NODES[3985].Fix(BODY_FORCE_Y); -NODES[3985].Fix(BODY_FORCE_Z); -NODES[3987].Fix(BODY_FORCE_X); -NODES[3987].Fix(BODY_FORCE_Y); -NODES[3987].Fix(BODY_FORCE_Z); -NODES[3988].Fix(BODY_FORCE_X); -NODES[3988].Fix(BODY_FORCE_Y); -NODES[3988].Fix(BODY_FORCE_Z); -NODES[3989].Fix(BODY_FORCE_X); -NODES[3989].Fix(BODY_FORCE_Y); -NODES[3989].Fix(BODY_FORCE_Z); -NODES[3990].Fix(BODY_FORCE_X); -NODES[3990].Fix(BODY_FORCE_Y); -NODES[3990].Fix(BODY_FORCE_Z); -NODES[3991].Fix(BODY_FORCE_X); -NODES[3991].Fix(BODY_FORCE_Y); -NODES[3991].Fix(BODY_FORCE_Z); -NODES[3992].Fix(BODY_FORCE_X); -NODES[3992].Fix(BODY_FORCE_Y); -NODES[3992].Fix(BODY_FORCE_Z); -NODES[3993].Fix(BODY_FORCE_X); -NODES[3993].Fix(BODY_FORCE_Y); -NODES[3993].Fix(BODY_FORCE_Z); -NODES[3994].Fix(BODY_FORCE_X); -NODES[3994].Fix(BODY_FORCE_Y); -NODES[3994].Fix(BODY_FORCE_Z); -NODES[3996].Fix(BODY_FORCE_X); -NODES[3996].Fix(BODY_FORCE_Y); -NODES[3996].Fix(BODY_FORCE_Z); -NODES[3997].Fix(BODY_FORCE_X); -NODES[3997].Fix(BODY_FORCE_Y); -NODES[3997].Fix(BODY_FORCE_Z); -NODES[3998].Fix(BODY_FORCE_X); -NODES[3998].Fix(BODY_FORCE_Y); -NODES[3998].Fix(BODY_FORCE_Z); -NODES[3999].Fix(BODY_FORCE_X); -NODES[3999].Fix(BODY_FORCE_Y); -NODES[3999].Fix(BODY_FORCE_Z); -NODES[4000].Fix(BODY_FORCE_X); -NODES[4000].Fix(BODY_FORCE_Y); -NODES[4000].Fix(BODY_FORCE_Z); -NODES[4001].Fix(BODY_FORCE_X); -NODES[4001].Fix(BODY_FORCE_Y); -NODES[4001].Fix(BODY_FORCE_Z); -NODES[4002].Fix(BODY_FORCE_X); -NODES[4002].Fix(BODY_FORCE_Y); -NODES[4002].Fix(BODY_FORCE_Z); -NODES[4004].Fix(BODY_FORCE_X); -NODES[4004].Fix(BODY_FORCE_Y); -NODES[4004].Fix(BODY_FORCE_Z); -NODES[4005].Fix(BODY_FORCE_X); -NODES[4005].Fix(BODY_FORCE_Y); -NODES[4005].Fix(BODY_FORCE_Z); -NODES[4006].Fix(BODY_FORCE_X); -NODES[4006].Fix(BODY_FORCE_Y); -NODES[4006].Fix(BODY_FORCE_Z); -NODES[4007].Fix(BODY_FORCE_X); -NODES[4007].Fix(BODY_FORCE_Y); -NODES[4007].Fix(BODY_FORCE_Z); -NODES[4008].Fix(BODY_FORCE_X); -NODES[4008].Fix(BODY_FORCE_Y); -NODES[4008].Fix(BODY_FORCE_Z); -NODES[4009].Fix(BODY_FORCE_X); -NODES[4009].Fix(BODY_FORCE_Y); -NODES[4009].Fix(BODY_FORCE_Z); -NODES[4010].Fix(BODY_FORCE_X); -NODES[4010].Fix(BODY_FORCE_Y); -NODES[4010].Fix(BODY_FORCE_Z); -NODES[4011].Fix(BODY_FORCE_X); -NODES[4011].Fix(BODY_FORCE_Y); -NODES[4011].Fix(BODY_FORCE_Z); -NODES[4012].Fix(BODY_FORCE_X); -NODES[4012].Fix(BODY_FORCE_Y); -NODES[4012].Fix(BODY_FORCE_Z); -NODES[4013].Fix(BODY_FORCE_X); -NODES[4013].Fix(BODY_FORCE_Y); -NODES[4013].Fix(BODY_FORCE_Z); -NODES[4015].Fix(BODY_FORCE_X); -NODES[4015].Fix(BODY_FORCE_Y); -NODES[4015].Fix(BODY_FORCE_Z); -NODES[4016].Fix(BODY_FORCE_X); -NODES[4016].Fix(BODY_FORCE_Y); -NODES[4016].Fix(BODY_FORCE_Z); -NODES[4017].Fix(BODY_FORCE_X); -NODES[4017].Fix(BODY_FORCE_Y); -NODES[4017].Fix(BODY_FORCE_Z); -NODES[4018].Fix(BODY_FORCE_X); -NODES[4018].Fix(BODY_FORCE_Y); -NODES[4018].Fix(BODY_FORCE_Z); -NODES[4019].Fix(BODY_FORCE_X); -NODES[4019].Fix(BODY_FORCE_Y); -NODES[4019].Fix(BODY_FORCE_Z); -NODES[4020].Fix(BODY_FORCE_X); -NODES[4020].Fix(BODY_FORCE_Y); -NODES[4020].Fix(BODY_FORCE_Z); -NODES[4021].Fix(BODY_FORCE_X); -NODES[4021].Fix(BODY_FORCE_Y); -NODES[4021].Fix(BODY_FORCE_Z); -NODES[4022].Fix(BODY_FORCE_X); -NODES[4022].Fix(BODY_FORCE_Y); -NODES[4022].Fix(BODY_FORCE_Z); -NODES[4023].Fix(BODY_FORCE_X); -NODES[4023].Fix(BODY_FORCE_Y); -NODES[4023].Fix(BODY_FORCE_Z); -NODES[4025].Fix(BODY_FORCE_X); -NODES[4025].Fix(BODY_FORCE_Y); -NODES[4025].Fix(BODY_FORCE_Z); -NODES[4026].Fix(BODY_FORCE_X); -NODES[4026].Fix(BODY_FORCE_Y); -NODES[4026].Fix(BODY_FORCE_Z); -NODES[4027].Fix(BODY_FORCE_X); -NODES[4027].Fix(BODY_FORCE_Y); -NODES[4027].Fix(BODY_FORCE_Z); -NODES[4028].Fix(BODY_FORCE_X); -NODES[4028].Fix(BODY_FORCE_Y); -NODES[4028].Fix(BODY_FORCE_Z); -NODES[4029].Fix(BODY_FORCE_X); -NODES[4029].Fix(BODY_FORCE_Y); -NODES[4029].Fix(BODY_FORCE_Z); -NODES[4030].Fix(BODY_FORCE_X); -NODES[4030].Fix(BODY_FORCE_Y); -NODES[4030].Fix(BODY_FORCE_Z); -NODES[4031].Fix(BODY_FORCE_X); -NODES[4031].Fix(BODY_FORCE_Y); -NODES[4031].Fix(BODY_FORCE_Z); -NODES[4032].Fix(BODY_FORCE_X); -NODES[4032].Fix(BODY_FORCE_Y); -NODES[4032].Fix(BODY_FORCE_Z); -NODES[4034].Fix(BODY_FORCE_X); -NODES[4034].Fix(BODY_FORCE_Y); -NODES[4034].Fix(BODY_FORCE_Z); -NODES[4035].Fix(BODY_FORCE_X); -NODES[4035].Fix(BODY_FORCE_Y); -NODES[4035].Fix(BODY_FORCE_Z); -NODES[4036].Fix(BODY_FORCE_X); -NODES[4036].Fix(BODY_FORCE_Y); -NODES[4036].Fix(BODY_FORCE_Z); -NODES[4037].Fix(BODY_FORCE_X); -NODES[4037].Fix(BODY_FORCE_Y); -NODES[4037].Fix(BODY_FORCE_Z); -NODES[4038].Fix(BODY_FORCE_X); -NODES[4038].Fix(BODY_FORCE_Y); -NODES[4038].Fix(BODY_FORCE_Z); -NODES[4039].Fix(BODY_FORCE_X); -NODES[4039].Fix(BODY_FORCE_Y); -NODES[4039].Fix(BODY_FORCE_Z); -NODES[4040].Fix(BODY_FORCE_X); -NODES[4040].Fix(BODY_FORCE_Y); -NODES[4040].Fix(BODY_FORCE_Z); -NODES[4041].Fix(BODY_FORCE_X); -NODES[4041].Fix(BODY_FORCE_Y); -NODES[4041].Fix(BODY_FORCE_Z); -NODES[4042].Fix(BODY_FORCE_X); -NODES[4042].Fix(BODY_FORCE_Y); -NODES[4042].Fix(BODY_FORCE_Z); -NODES[4043].Fix(BODY_FORCE_X); -NODES[4043].Fix(BODY_FORCE_Y); -NODES[4043].Fix(BODY_FORCE_Z); -NODES[4045].Fix(BODY_FORCE_X); -NODES[4045].Fix(BODY_FORCE_Y); -NODES[4045].Fix(BODY_FORCE_Z); -NODES[4046].Fix(BODY_FORCE_X); -NODES[4046].Fix(BODY_FORCE_Y); -NODES[4046].Fix(BODY_FORCE_Z); -NODES[4047].Fix(BODY_FORCE_X); -NODES[4047].Fix(BODY_FORCE_Y); -NODES[4047].Fix(BODY_FORCE_Z); -NODES[4048].Fix(BODY_FORCE_X); -NODES[4048].Fix(BODY_FORCE_Y); -NODES[4048].Fix(BODY_FORCE_Z); -NODES[4049].Fix(BODY_FORCE_X); -NODES[4049].Fix(BODY_FORCE_Y); -NODES[4049].Fix(BODY_FORCE_Z); -NODES[4050].Fix(BODY_FORCE_X); -NODES[4050].Fix(BODY_FORCE_Y); -NODES[4050].Fix(BODY_FORCE_Z); -NODES[4051].Fix(BODY_FORCE_X); -NODES[4051].Fix(BODY_FORCE_Y); -NODES[4051].Fix(BODY_FORCE_Z); -NODES[4052].Fix(BODY_FORCE_X); -NODES[4052].Fix(BODY_FORCE_Y); -NODES[4052].Fix(BODY_FORCE_Z); -NODES[4054].Fix(BODY_FORCE_X); -NODES[4054].Fix(BODY_FORCE_Y); -NODES[4054].Fix(BODY_FORCE_Z); -NODES[4055].Fix(BODY_FORCE_X); -NODES[4055].Fix(BODY_FORCE_Y); -NODES[4055].Fix(BODY_FORCE_Z); -NODES[4056].Fix(BODY_FORCE_X); -NODES[4056].Fix(BODY_FORCE_Y); -NODES[4056].Fix(BODY_FORCE_Z); -NODES[4057].Fix(BODY_FORCE_X); -NODES[4057].Fix(BODY_FORCE_Y); -NODES[4057].Fix(BODY_FORCE_Z); -NODES[4058].Fix(BODY_FORCE_X); -NODES[4058].Fix(BODY_FORCE_Y); -NODES[4058].Fix(BODY_FORCE_Z); -NODES[4059].Fix(BODY_FORCE_X); -NODES[4059].Fix(BODY_FORCE_Y); -NODES[4059].Fix(BODY_FORCE_Z); -NODES[4060].Fix(BODY_FORCE_X); -NODES[4060].Fix(BODY_FORCE_Y); -NODES[4060].Fix(BODY_FORCE_Z); -NODES[4061].Fix(BODY_FORCE_X); -NODES[4061].Fix(BODY_FORCE_Y); -NODES[4061].Fix(BODY_FORCE_Z); -NODES[4062].Fix(BODY_FORCE_X); -NODES[4062].Fix(BODY_FORCE_Y); -NODES[4062].Fix(BODY_FORCE_Z); -NODES[4063].Fix(BODY_FORCE_X); -NODES[4063].Fix(BODY_FORCE_Y); -NODES[4063].Fix(BODY_FORCE_Z); -NODES[4064].Fix(BODY_FORCE_X); -NODES[4064].Fix(BODY_FORCE_Y); -NODES[4064].Fix(BODY_FORCE_Z); -NODES[4066].Fix(BODY_FORCE_X); -NODES[4066].Fix(BODY_FORCE_Y); -NODES[4066].Fix(BODY_FORCE_Z); -NODES[4067].Fix(BODY_FORCE_X); -NODES[4067].Fix(BODY_FORCE_Y); -NODES[4067].Fix(BODY_FORCE_Z); -NODES[4068].Fix(BODY_FORCE_X); -NODES[4068].Fix(BODY_FORCE_Y); -NODES[4068].Fix(BODY_FORCE_Z); -NODES[4069].Fix(BODY_FORCE_X); -NODES[4069].Fix(BODY_FORCE_Y); -NODES[4069].Fix(BODY_FORCE_Z); -NODES[4070].Fix(BODY_FORCE_X); -NODES[4070].Fix(BODY_FORCE_Y); -NODES[4070].Fix(BODY_FORCE_Z); -NODES[4071].Fix(BODY_FORCE_X); -NODES[4071].Fix(BODY_FORCE_Y); -NODES[4071].Fix(BODY_FORCE_Z); -NODES[4073].Fix(BODY_FORCE_X); -NODES[4073].Fix(BODY_FORCE_Y); -NODES[4073].Fix(BODY_FORCE_Z); -NODES[4074].Fix(BODY_FORCE_X); -NODES[4074].Fix(BODY_FORCE_Y); -NODES[4074].Fix(BODY_FORCE_Z); -NODES[4075].Fix(BODY_FORCE_X); -NODES[4075].Fix(BODY_FORCE_Y); -NODES[4075].Fix(BODY_FORCE_Z); -NODES[4076].Fix(BODY_FORCE_X); -NODES[4076].Fix(BODY_FORCE_Y); -NODES[4076].Fix(BODY_FORCE_Z); -NODES[4077].Fix(BODY_FORCE_X); -NODES[4077].Fix(BODY_FORCE_Y); -NODES[4077].Fix(BODY_FORCE_Z); -NODES[4078].Fix(BODY_FORCE_X); -NODES[4078].Fix(BODY_FORCE_Y); -NODES[4078].Fix(BODY_FORCE_Z); -NODES[4079].Fix(BODY_FORCE_X); -NODES[4079].Fix(BODY_FORCE_Y); -NODES[4079].Fix(BODY_FORCE_Z); -NODES[4080].Fix(BODY_FORCE_X); -NODES[4080].Fix(BODY_FORCE_Y); -NODES[4080].Fix(BODY_FORCE_Z); -NODES[4081].Fix(BODY_FORCE_X); -NODES[4081].Fix(BODY_FORCE_Y); -NODES[4081].Fix(BODY_FORCE_Z); -NODES[4082].Fix(BODY_FORCE_X); -NODES[4082].Fix(BODY_FORCE_Y); -NODES[4082].Fix(BODY_FORCE_Z); -NODES[4083].Fix(BODY_FORCE_X); -NODES[4083].Fix(BODY_FORCE_Y); -NODES[4083].Fix(BODY_FORCE_Z); -NODES[4084].Fix(BODY_FORCE_X); -NODES[4084].Fix(BODY_FORCE_Y); -NODES[4084].Fix(BODY_FORCE_Z); -NODES[4085].Fix(BODY_FORCE_X); -NODES[4085].Fix(BODY_FORCE_Y); -NODES[4085].Fix(BODY_FORCE_Z); -NODES[4087].Fix(BODY_FORCE_X); -NODES[4087].Fix(BODY_FORCE_Y); -NODES[4087].Fix(BODY_FORCE_Z); -NODES[4088].Fix(BODY_FORCE_X); -NODES[4088].Fix(BODY_FORCE_Y); -NODES[4088].Fix(BODY_FORCE_Z); -NODES[4089].Fix(BODY_FORCE_X); -NODES[4089].Fix(BODY_FORCE_Y); -NODES[4089].Fix(BODY_FORCE_Z); -NODES[4090].Fix(BODY_FORCE_X); -NODES[4090].Fix(BODY_FORCE_Y); -NODES[4090].Fix(BODY_FORCE_Z); -NODES[4091].Fix(BODY_FORCE_X); -NODES[4091].Fix(BODY_FORCE_Y); -NODES[4091].Fix(BODY_FORCE_Z); -NODES[4092].Fix(BODY_FORCE_X); -NODES[4092].Fix(BODY_FORCE_Y); -NODES[4092].Fix(BODY_FORCE_Z); -NODES[4093].Fix(BODY_FORCE_X); -NODES[4093].Fix(BODY_FORCE_Y); -NODES[4093].Fix(BODY_FORCE_Z); -NODES[4095].Fix(BODY_FORCE_X); -NODES[4095].Fix(BODY_FORCE_Y); -NODES[4095].Fix(BODY_FORCE_Z); -NODES[4096].Fix(BODY_FORCE_X); -NODES[4096].Fix(BODY_FORCE_Y); -NODES[4096].Fix(BODY_FORCE_Z); -NODES[4097].Fix(BODY_FORCE_X); -NODES[4097].Fix(BODY_FORCE_Y); -NODES[4097].Fix(BODY_FORCE_Z); -NODES[4098].Fix(BODY_FORCE_X); -NODES[4098].Fix(BODY_FORCE_Y); -NODES[4098].Fix(BODY_FORCE_Z); -NODES[4099].Fix(BODY_FORCE_X); -NODES[4099].Fix(BODY_FORCE_Y); -NODES[4099].Fix(BODY_FORCE_Z); -NODES[4100].Fix(BODY_FORCE_X); -NODES[4100].Fix(BODY_FORCE_Y); -NODES[4100].Fix(BODY_FORCE_Z); -NODES[4101].Fix(BODY_FORCE_X); -NODES[4101].Fix(BODY_FORCE_Y); -NODES[4101].Fix(BODY_FORCE_Z); -NODES[4102].Fix(BODY_FORCE_X); -NODES[4102].Fix(BODY_FORCE_Y); -NODES[4102].Fix(BODY_FORCE_Z); -NODES[4103].Fix(BODY_FORCE_X); -NODES[4103].Fix(BODY_FORCE_Y); -NODES[4103].Fix(BODY_FORCE_Z); -NODES[4104].Fix(BODY_FORCE_X); -NODES[4104].Fix(BODY_FORCE_Y); -NODES[4104].Fix(BODY_FORCE_Z); -NODES[4105].Fix(BODY_FORCE_X); -NODES[4105].Fix(BODY_FORCE_Y); -NODES[4105].Fix(BODY_FORCE_Z); -NODES[4107].Fix(BODY_FORCE_X); -NODES[4107].Fix(BODY_FORCE_Y); -NODES[4107].Fix(BODY_FORCE_Z); -NODES[4108].Fix(BODY_FORCE_X); -NODES[4108].Fix(BODY_FORCE_Y); -NODES[4108].Fix(BODY_FORCE_Z); -NODES[4109].Fix(BODY_FORCE_X); -NODES[4109].Fix(BODY_FORCE_Y); -NODES[4109].Fix(BODY_FORCE_Z); -NODES[4110].Fix(BODY_FORCE_X); -NODES[4110].Fix(BODY_FORCE_Y); -NODES[4110].Fix(BODY_FORCE_Z); -NODES[4111].Fix(BODY_FORCE_X); -NODES[4111].Fix(BODY_FORCE_Y); -NODES[4111].Fix(BODY_FORCE_Z); -NODES[4112].Fix(BODY_FORCE_X); -NODES[4112].Fix(BODY_FORCE_Y); -NODES[4112].Fix(BODY_FORCE_Z); -NODES[4113].Fix(BODY_FORCE_X); -NODES[4113].Fix(BODY_FORCE_Y); -NODES[4113].Fix(BODY_FORCE_Z); -NODES[4114].Fix(BODY_FORCE_X); -NODES[4114].Fix(BODY_FORCE_Y); -NODES[4114].Fix(BODY_FORCE_Z); -NODES[4115].Fix(BODY_FORCE_X); -NODES[4115].Fix(BODY_FORCE_Y); -NODES[4115].Fix(BODY_FORCE_Z); -NODES[4116].Fix(BODY_FORCE_X); -NODES[4116].Fix(BODY_FORCE_Y); -NODES[4116].Fix(BODY_FORCE_Z); -NODES[4117].Fix(BODY_FORCE_X); -NODES[4117].Fix(BODY_FORCE_Y); -NODES[4117].Fix(BODY_FORCE_Z); -NODES[4119].Fix(BODY_FORCE_X); -NODES[4119].Fix(BODY_FORCE_Y); -NODES[4119].Fix(BODY_FORCE_Z); -NODES[4120].Fix(BODY_FORCE_X); -NODES[4120].Fix(BODY_FORCE_Y); -NODES[4120].Fix(BODY_FORCE_Z); -NODES[4121].Fix(BODY_FORCE_X); -NODES[4121].Fix(BODY_FORCE_Y); -NODES[4121].Fix(BODY_FORCE_Z); -NODES[4122].Fix(BODY_FORCE_X); -NODES[4122].Fix(BODY_FORCE_Y); -NODES[4122].Fix(BODY_FORCE_Z); -NODES[4123].Fix(BODY_FORCE_X); -NODES[4123].Fix(BODY_FORCE_Y); -NODES[4123].Fix(BODY_FORCE_Z); -NODES[4124].Fix(BODY_FORCE_X); -NODES[4124].Fix(BODY_FORCE_Y); -NODES[4124].Fix(BODY_FORCE_Z); -NODES[4125].Fix(BODY_FORCE_X); -NODES[4125].Fix(BODY_FORCE_Y); -NODES[4125].Fix(BODY_FORCE_Z); -NODES[4126].Fix(BODY_FORCE_X); -NODES[4126].Fix(BODY_FORCE_Y); -NODES[4126].Fix(BODY_FORCE_Z); -NODES[4127].Fix(BODY_FORCE_X); -NODES[4127].Fix(BODY_FORCE_Y); -NODES[4127].Fix(BODY_FORCE_Z); -NODES[4129].Fix(BODY_FORCE_X); -NODES[4129].Fix(BODY_FORCE_Y); -NODES[4129].Fix(BODY_FORCE_Z); -NODES[4130].Fix(BODY_FORCE_X); -NODES[4130].Fix(BODY_FORCE_Y); -NODES[4130].Fix(BODY_FORCE_Z); -NODES[4131].Fix(BODY_FORCE_X); -NODES[4131].Fix(BODY_FORCE_Y); -NODES[4131].Fix(BODY_FORCE_Z); -NODES[4132].Fix(BODY_FORCE_X); -NODES[4132].Fix(BODY_FORCE_Y); -NODES[4132].Fix(BODY_FORCE_Z); -NODES[4133].Fix(BODY_FORCE_X); -NODES[4133].Fix(BODY_FORCE_Y); -NODES[4133].Fix(BODY_FORCE_Z); -NODES[4134].Fix(BODY_FORCE_X); -NODES[4134].Fix(BODY_FORCE_Y); -NODES[4134].Fix(BODY_FORCE_Z); -NODES[4135].Fix(BODY_FORCE_X); -NODES[4135].Fix(BODY_FORCE_Y); -NODES[4135].Fix(BODY_FORCE_Z); -NODES[4136].Fix(BODY_FORCE_X); -NODES[4136].Fix(BODY_FORCE_Y); -NODES[4136].Fix(BODY_FORCE_Z); -NODES[4137].Fix(BODY_FORCE_X); -NODES[4137].Fix(BODY_FORCE_Y); -NODES[4137].Fix(BODY_FORCE_Z); -NODES[4138].Fix(BODY_FORCE_X); -NODES[4138].Fix(BODY_FORCE_Y); -NODES[4138].Fix(BODY_FORCE_Z); -NODES[4140].Fix(BODY_FORCE_X); -NODES[4140].Fix(BODY_FORCE_Y); -NODES[4140].Fix(BODY_FORCE_Z); -NODES[4141].Fix(BODY_FORCE_X); -NODES[4141].Fix(BODY_FORCE_Y); -NODES[4141].Fix(BODY_FORCE_Z); -NODES[4142].Fix(BODY_FORCE_X); -NODES[4142].Fix(BODY_FORCE_Y); -NODES[4142].Fix(BODY_FORCE_Z); -NODES[4143].Fix(BODY_FORCE_X); -NODES[4143].Fix(BODY_FORCE_Y); -NODES[4143].Fix(BODY_FORCE_Z); -NODES[4144].Fix(BODY_FORCE_X); -NODES[4144].Fix(BODY_FORCE_Y); -NODES[4144].Fix(BODY_FORCE_Z); -NODES[4145].Fix(BODY_FORCE_X); -NODES[4145].Fix(BODY_FORCE_Y); -NODES[4145].Fix(BODY_FORCE_Z); -NODES[4146].Fix(BODY_FORCE_X); -NODES[4146].Fix(BODY_FORCE_Y); -NODES[4146].Fix(BODY_FORCE_Z); -NODES[4147].Fix(BODY_FORCE_X); -NODES[4147].Fix(BODY_FORCE_Y); -NODES[4147].Fix(BODY_FORCE_Z); -NODES[4148].Fix(BODY_FORCE_X); -NODES[4148].Fix(BODY_FORCE_Y); -NODES[4148].Fix(BODY_FORCE_Z); -NODES[4150].Fix(BODY_FORCE_X); -NODES[4150].Fix(BODY_FORCE_Y); -NODES[4150].Fix(BODY_FORCE_Z); -NODES[4151].Fix(BODY_FORCE_X); -NODES[4151].Fix(BODY_FORCE_Y); -NODES[4151].Fix(BODY_FORCE_Z); -NODES[4152].Fix(BODY_FORCE_X); -NODES[4152].Fix(BODY_FORCE_Y); -NODES[4152].Fix(BODY_FORCE_Z); -NODES[4153].Fix(BODY_FORCE_X); -NODES[4153].Fix(BODY_FORCE_Y); -NODES[4153].Fix(BODY_FORCE_Z); -NODES[4154].Fix(BODY_FORCE_X); -NODES[4154].Fix(BODY_FORCE_Y); -NODES[4154].Fix(BODY_FORCE_Z); -NODES[4155].Fix(BODY_FORCE_X); -NODES[4155].Fix(BODY_FORCE_Y); -NODES[4155].Fix(BODY_FORCE_Z); -NODES[4156].Fix(BODY_FORCE_X); -NODES[4156].Fix(BODY_FORCE_Y); -NODES[4156].Fix(BODY_FORCE_Z); -NODES[4157].Fix(BODY_FORCE_X); -NODES[4157].Fix(BODY_FORCE_Y); -NODES[4157].Fix(BODY_FORCE_Z); -NODES[4158].Fix(BODY_FORCE_X); -NODES[4158].Fix(BODY_FORCE_Y); -NODES[4158].Fix(BODY_FORCE_Z); -NODES[4159].Fix(BODY_FORCE_X); -NODES[4159].Fix(BODY_FORCE_Y); -NODES[4159].Fix(BODY_FORCE_Z); -NODES[4160].Fix(BODY_FORCE_X); -NODES[4160].Fix(BODY_FORCE_Y); -NODES[4160].Fix(BODY_FORCE_Z); -NODES[4161].Fix(BODY_FORCE_X); -NODES[4161].Fix(BODY_FORCE_Y); -NODES[4161].Fix(BODY_FORCE_Z); -NODES[4162].Fix(BODY_FORCE_X); -NODES[4162].Fix(BODY_FORCE_Y); -NODES[4162].Fix(BODY_FORCE_Z); -NODES[4164].Fix(BODY_FORCE_X); -NODES[4164].Fix(BODY_FORCE_Y); -NODES[4164].Fix(BODY_FORCE_Z); -NODES[4165].Fix(BODY_FORCE_X); -NODES[4165].Fix(BODY_FORCE_Y); -NODES[4165].Fix(BODY_FORCE_Z); -NODES[4166].Fix(BODY_FORCE_X); -NODES[4166].Fix(BODY_FORCE_Y); -NODES[4166].Fix(BODY_FORCE_Z); -NODES[4167].Fix(BODY_FORCE_X); -NODES[4167].Fix(BODY_FORCE_Y); -NODES[4167].Fix(BODY_FORCE_Z); -NODES[4168].Fix(BODY_FORCE_X); -NODES[4168].Fix(BODY_FORCE_Y); -NODES[4168].Fix(BODY_FORCE_Z); -NODES[4169].Fix(BODY_FORCE_X); -NODES[4169].Fix(BODY_FORCE_Y); -NODES[4169].Fix(BODY_FORCE_Z); -NODES[4170].Fix(BODY_FORCE_X); -NODES[4170].Fix(BODY_FORCE_Y); -NODES[4170].Fix(BODY_FORCE_Z); -NODES[4171].Fix(BODY_FORCE_X); -NODES[4171].Fix(BODY_FORCE_Y); -NODES[4171].Fix(BODY_FORCE_Z); -NODES[4172].Fix(BODY_FORCE_X); -NODES[4172].Fix(BODY_FORCE_Y); -NODES[4172].Fix(BODY_FORCE_Z); -NODES[4174].Fix(BODY_FORCE_X); -NODES[4174].Fix(BODY_FORCE_Y); -NODES[4174].Fix(BODY_FORCE_Z); -NODES[4175].Fix(BODY_FORCE_X); -NODES[4175].Fix(BODY_FORCE_Y); -NODES[4175].Fix(BODY_FORCE_Z); -NODES[4176].Fix(BODY_FORCE_X); -NODES[4176].Fix(BODY_FORCE_Y); -NODES[4176].Fix(BODY_FORCE_Z); -NODES[4177].Fix(BODY_FORCE_X); -NODES[4177].Fix(BODY_FORCE_Y); -NODES[4177].Fix(BODY_FORCE_Z); -NODES[4178].Fix(BODY_FORCE_X); -NODES[4178].Fix(BODY_FORCE_Y); -NODES[4178].Fix(BODY_FORCE_Z); -NODES[4179].Fix(BODY_FORCE_X); -NODES[4179].Fix(BODY_FORCE_Y); -NODES[4179].Fix(BODY_FORCE_Z); -NODES[4180].Fix(BODY_FORCE_X); -NODES[4180].Fix(BODY_FORCE_Y); -NODES[4180].Fix(BODY_FORCE_Z); -NODES[4181].Fix(BODY_FORCE_X); -NODES[4181].Fix(BODY_FORCE_Y); -NODES[4181].Fix(BODY_FORCE_Z); -NODES[4182].Fix(BODY_FORCE_X); -NODES[4182].Fix(BODY_FORCE_Y); -NODES[4182].Fix(BODY_FORCE_Z); -NODES[4183].Fix(BODY_FORCE_X); -NODES[4183].Fix(BODY_FORCE_Y); -NODES[4183].Fix(BODY_FORCE_Z); -NODES[4184].Fix(BODY_FORCE_X); -NODES[4184].Fix(BODY_FORCE_Y); -NODES[4184].Fix(BODY_FORCE_Z); -NODES[4185].Fix(BODY_FORCE_X); -NODES[4185].Fix(BODY_FORCE_Y); -NODES[4185].Fix(BODY_FORCE_Z); -NODES[4186].Fix(BODY_FORCE_X); -NODES[4186].Fix(BODY_FORCE_Y); -NODES[4186].Fix(BODY_FORCE_Z); -NODES[4187].Fix(BODY_FORCE_X); -NODES[4187].Fix(BODY_FORCE_Y); -NODES[4187].Fix(BODY_FORCE_Z); -NODES[4188].Fix(BODY_FORCE_X); -NODES[4188].Fix(BODY_FORCE_Y); -NODES[4188].Fix(BODY_FORCE_Z); -NODES[4189].Fix(BODY_FORCE_X); -NODES[4189].Fix(BODY_FORCE_Y); -NODES[4189].Fix(BODY_FORCE_Z); -NODES[4190].Fix(BODY_FORCE_X); -NODES[4190].Fix(BODY_FORCE_Y); -NODES[4190].Fix(BODY_FORCE_Z); -NODES[4191].Fix(BODY_FORCE_X); -NODES[4191].Fix(BODY_FORCE_Y); -NODES[4191].Fix(BODY_FORCE_Z); -NODES[4192].Fix(BODY_FORCE_X); -NODES[4192].Fix(BODY_FORCE_Y); -NODES[4192].Fix(BODY_FORCE_Z); -NODES[4193].Fix(BODY_FORCE_X); -NODES[4193].Fix(BODY_FORCE_Y); -NODES[4193].Fix(BODY_FORCE_Z); -NODES[4194].Fix(BODY_FORCE_X); -NODES[4194].Fix(BODY_FORCE_Y); -NODES[4194].Fix(BODY_FORCE_Z); -NODES[4195].Fix(BODY_FORCE_X); -NODES[4195].Fix(BODY_FORCE_Y); -NODES[4195].Fix(BODY_FORCE_Z); -NODES[4196].Fix(BODY_FORCE_X); -NODES[4196].Fix(BODY_FORCE_Y); -NODES[4196].Fix(BODY_FORCE_Z); -NODES[4197].Fix(BODY_FORCE_X); -NODES[4197].Fix(BODY_FORCE_Y); -NODES[4197].Fix(BODY_FORCE_Z); -NODES[4198].Fix(BODY_FORCE_X); -NODES[4198].Fix(BODY_FORCE_Y); -NODES[4198].Fix(BODY_FORCE_Z); -NODES[4199].Fix(BODY_FORCE_X); -NODES[4199].Fix(BODY_FORCE_Y); -NODES[4199].Fix(BODY_FORCE_Z); -NODES[4200].Fix(BODY_FORCE_X); -NODES[4200].Fix(BODY_FORCE_Y); -NODES[4200].Fix(BODY_FORCE_Z); -NODES[4201].Fix(BODY_FORCE_X); -NODES[4201].Fix(BODY_FORCE_Y); -NODES[4201].Fix(BODY_FORCE_Z); -NODES[4202].Fix(BODY_FORCE_X); -NODES[4202].Fix(BODY_FORCE_Y); -NODES[4202].Fix(BODY_FORCE_Z); -NODES[4203].Fix(BODY_FORCE_X); -NODES[4203].Fix(BODY_FORCE_Y); -NODES[4203].Fix(BODY_FORCE_Z); -NODES[4204].Fix(BODY_FORCE_X); -NODES[4204].Fix(BODY_FORCE_Y); -NODES[4204].Fix(BODY_FORCE_Z); -NODES[4205].Fix(BODY_FORCE_X); -NODES[4205].Fix(BODY_FORCE_Y); -NODES[4205].Fix(BODY_FORCE_Z); -NODES[4206].Fix(BODY_FORCE_X); -NODES[4206].Fix(BODY_FORCE_Y); -NODES[4206].Fix(BODY_FORCE_Z); -NODES[4207].Fix(BODY_FORCE_X); -NODES[4207].Fix(BODY_FORCE_Y); -NODES[4207].Fix(BODY_FORCE_Z); -NODES[4208].Fix(BODY_FORCE_X); -NODES[4208].Fix(BODY_FORCE_Y); -NODES[4208].Fix(BODY_FORCE_Z); -NODES[4209].Fix(BODY_FORCE_X); -NODES[4209].Fix(BODY_FORCE_Y); -NODES[4209].Fix(BODY_FORCE_Z); -NODES[4210].Fix(BODY_FORCE_X); -NODES[4210].Fix(BODY_FORCE_Y); -NODES[4210].Fix(BODY_FORCE_Z); -NODES[4211].Fix(BODY_FORCE_X); -NODES[4211].Fix(BODY_FORCE_Y); -NODES[4211].Fix(BODY_FORCE_Z); -NODES[4212].Fix(BODY_FORCE_X); -NODES[4212].Fix(BODY_FORCE_Y); -NODES[4212].Fix(BODY_FORCE_Z); -NODES[4213].Fix(BODY_FORCE_X); -NODES[4213].Fix(BODY_FORCE_Y); -NODES[4213].Fix(BODY_FORCE_Z); -NODES[4214].Fix(BODY_FORCE_X); -NODES[4214].Fix(BODY_FORCE_Y); -NODES[4214].Fix(BODY_FORCE_Z); -NODES[4215].Fix(BODY_FORCE_X); -NODES[4215].Fix(BODY_FORCE_Y); -NODES[4215].Fix(BODY_FORCE_Z); -NODES[4216].Fix(BODY_FORCE_X); -NODES[4216].Fix(BODY_FORCE_Y); -NODES[4216].Fix(BODY_FORCE_Z); -NODES[4217].Fix(BODY_FORCE_X); -NODES[4217].Fix(BODY_FORCE_Y); -NODES[4217].Fix(BODY_FORCE_Z); -NODES[4218].Fix(BODY_FORCE_X); -NODES[4218].Fix(BODY_FORCE_Y); -NODES[4218].Fix(BODY_FORCE_Z); -NODES[4219].Fix(BODY_FORCE_X); -NODES[4219].Fix(BODY_FORCE_Y); -NODES[4219].Fix(BODY_FORCE_Z); -NODES[4220].Fix(BODY_FORCE_X); -NODES[4220].Fix(BODY_FORCE_Y); -NODES[4220].Fix(BODY_FORCE_Z); -NODES[4221].Fix(BODY_FORCE_X); -NODES[4221].Fix(BODY_FORCE_Y); -NODES[4221].Fix(BODY_FORCE_Z); -NODES[4222].Fix(BODY_FORCE_X); -NODES[4222].Fix(BODY_FORCE_Y); -NODES[4222].Fix(BODY_FORCE_Z); -NODES[4223].Fix(BODY_FORCE_X); -NODES[4223].Fix(BODY_FORCE_Y); -NODES[4223].Fix(BODY_FORCE_Z); -NODES[4224].Fix(BODY_FORCE_X); -NODES[4224].Fix(BODY_FORCE_Y); -NODES[4224].Fix(BODY_FORCE_Z); -NODES[4225].Fix(BODY_FORCE_X); -NODES[4225].Fix(BODY_FORCE_Y); -NODES[4225].Fix(BODY_FORCE_Z); -NODES[4226].Fix(BODY_FORCE_X); -NODES[4226].Fix(BODY_FORCE_Y); -NODES[4226].Fix(BODY_FORCE_Z); -NODES[4227].Fix(BODY_FORCE_X); -NODES[4227].Fix(BODY_FORCE_Y); -NODES[4227].Fix(BODY_FORCE_Z); -NODES[4228].Fix(BODY_FORCE_X); -NODES[4228].Fix(BODY_FORCE_Y); -NODES[4228].Fix(BODY_FORCE_Z); -NODES[4229].Fix(BODY_FORCE_X); -NODES[4229].Fix(BODY_FORCE_Y); -NODES[4229].Fix(BODY_FORCE_Z); -NODES[4230].Fix(BODY_FORCE_X); -NODES[4230].Fix(BODY_FORCE_Y); -NODES[4230].Fix(BODY_FORCE_Z); -NODES[4231].Fix(BODY_FORCE_X); -NODES[4231].Fix(BODY_FORCE_Y); -NODES[4231].Fix(BODY_FORCE_Z); -NODES[4232].Fix(BODY_FORCE_X); -NODES[4232].Fix(BODY_FORCE_Y); -NODES[4232].Fix(BODY_FORCE_Z); -NODES[4233].Fix(BODY_FORCE_X); -NODES[4233].Fix(BODY_FORCE_Y); -NODES[4233].Fix(BODY_FORCE_Z); -NODES[4234].Fix(BODY_FORCE_X); -NODES[4234].Fix(BODY_FORCE_Y); -NODES[4234].Fix(BODY_FORCE_Z); -NODES[4235].Fix(BODY_FORCE_X); -NODES[4235].Fix(BODY_FORCE_Y); -NODES[4235].Fix(BODY_FORCE_Z); -NODES[4236].Fix(BODY_FORCE_X); -NODES[4236].Fix(BODY_FORCE_Y); -NODES[4236].Fix(BODY_FORCE_Z); -NODES[4237].Fix(BODY_FORCE_X); -NODES[4237].Fix(BODY_FORCE_Y); -NODES[4237].Fix(BODY_FORCE_Z); -NODES[4238].Fix(BODY_FORCE_X); -NODES[4238].Fix(BODY_FORCE_Y); -NODES[4238].Fix(BODY_FORCE_Z); -NODES[4239].Fix(BODY_FORCE_X); -NODES[4239].Fix(BODY_FORCE_Y); -NODES[4239].Fix(BODY_FORCE_Z); -NODES[4240].Fix(BODY_FORCE_X); -NODES[4240].Fix(BODY_FORCE_Y); -NODES[4240].Fix(BODY_FORCE_Z); -NODES[4241].Fix(BODY_FORCE_X); -NODES[4241].Fix(BODY_FORCE_Y); -NODES[4241].Fix(BODY_FORCE_Z); -NODES[4242].Fix(BODY_FORCE_X); -NODES[4242].Fix(BODY_FORCE_Y); -NODES[4242].Fix(BODY_FORCE_Z); -NODES[4243].Fix(BODY_FORCE_X); -NODES[4243].Fix(BODY_FORCE_Y); -NODES[4243].Fix(BODY_FORCE_Z); -NODES[4244].Fix(BODY_FORCE_X); -NODES[4244].Fix(BODY_FORCE_Y); -NODES[4244].Fix(BODY_FORCE_Z); -NODES[4245].Fix(BODY_FORCE_X); -NODES[4245].Fix(BODY_FORCE_Y); -NODES[4245].Fix(BODY_FORCE_Z); -NODES[4246].Fix(BODY_FORCE_X); -NODES[4246].Fix(BODY_FORCE_Y); -NODES[4246].Fix(BODY_FORCE_Z); -NODES[4247].Fix(BODY_FORCE_X); -NODES[4247].Fix(BODY_FORCE_Y); -NODES[4247].Fix(BODY_FORCE_Z); -NODES[4248].Fix(BODY_FORCE_X); -NODES[4248].Fix(BODY_FORCE_Y); -NODES[4248].Fix(BODY_FORCE_Z); -NODES[4249].Fix(BODY_FORCE_X); -NODES[4249].Fix(BODY_FORCE_Y); -NODES[4249].Fix(BODY_FORCE_Z); -NODES[4250].Fix(BODY_FORCE_X); -NODES[4250].Fix(BODY_FORCE_Y); -NODES[4250].Fix(BODY_FORCE_Z); -NODES[4251].Fix(BODY_FORCE_X); -NODES[4251].Fix(BODY_FORCE_Y); -NODES[4251].Fix(BODY_FORCE_Z); -NODES[4252].Fix(BODY_FORCE_X); -NODES[4252].Fix(BODY_FORCE_Y); -NODES[4252].Fix(BODY_FORCE_Z); -NODES[4253].Fix(BODY_FORCE_X); -NODES[4253].Fix(BODY_FORCE_Y); -NODES[4253].Fix(BODY_FORCE_Z); -NODES[4254].Fix(BODY_FORCE_X); -NODES[4254].Fix(BODY_FORCE_Y); -NODES[4254].Fix(BODY_FORCE_Z); -NODES[4255].Fix(BODY_FORCE_X); -NODES[4255].Fix(BODY_FORCE_Y); -NODES[4255].Fix(BODY_FORCE_Z); -NODES[4256].Fix(BODY_FORCE_X); -NODES[4256].Fix(BODY_FORCE_Y); -NODES[4256].Fix(BODY_FORCE_Z); -NODES[4257].Fix(BODY_FORCE_X); -NODES[4257].Fix(BODY_FORCE_Y); -NODES[4257].Fix(BODY_FORCE_Z); -NODES[4258].Fix(BODY_FORCE_X); -NODES[4258].Fix(BODY_FORCE_Y); -NODES[4258].Fix(BODY_FORCE_Z); -NODES[4259].Fix(BODY_FORCE_X); -NODES[4259].Fix(BODY_FORCE_Y); -NODES[4259].Fix(BODY_FORCE_Z); -NODES[4260].Fix(BODY_FORCE_X); -NODES[4260].Fix(BODY_FORCE_Y); -NODES[4260].Fix(BODY_FORCE_Z); -NODES[4261].Fix(BODY_FORCE_X); -NODES[4261].Fix(BODY_FORCE_Y); -NODES[4261].Fix(BODY_FORCE_Z); -NODES[4262].Fix(BODY_FORCE_X); -NODES[4262].Fix(BODY_FORCE_Y); -NODES[4262].Fix(BODY_FORCE_Z); -NODES[4263].Fix(BODY_FORCE_X); -NODES[4263].Fix(BODY_FORCE_Y); -NODES[4263].Fix(BODY_FORCE_Z); -NODES[4264].Fix(BODY_FORCE_X); -NODES[4264].Fix(BODY_FORCE_Y); -NODES[4264].Fix(BODY_FORCE_Z); -NODES[4265].Fix(BODY_FORCE_X); -NODES[4265].Fix(BODY_FORCE_Y); -NODES[4265].Fix(BODY_FORCE_Z); -NODES[4266].Fix(BODY_FORCE_X); -NODES[4266].Fix(BODY_FORCE_Y); -NODES[4266].Fix(BODY_FORCE_Z); -NODES[4267].Fix(BODY_FORCE_X); -NODES[4267].Fix(BODY_FORCE_Y); -NODES[4267].Fix(BODY_FORCE_Z); -NODES[4268].Fix(BODY_FORCE_X); -NODES[4268].Fix(BODY_FORCE_Y); -NODES[4268].Fix(BODY_FORCE_Z); -NODES[4269].Fix(BODY_FORCE_X); -NODES[4269].Fix(BODY_FORCE_Y); -NODES[4269].Fix(BODY_FORCE_Z); -NODES[4270].Fix(BODY_FORCE_X); -NODES[4270].Fix(BODY_FORCE_Y); -NODES[4270].Fix(BODY_FORCE_Z); -NODES[4271].Fix(BODY_FORCE_X); -NODES[4271].Fix(BODY_FORCE_Y); -NODES[4271].Fix(BODY_FORCE_Z); -NODES[4272].Fix(BODY_FORCE_X); -NODES[4272].Fix(BODY_FORCE_Y); -NODES[4272].Fix(BODY_FORCE_Z); -NODES[4273].Fix(BODY_FORCE_X); -NODES[4273].Fix(BODY_FORCE_Y); -NODES[4273].Fix(BODY_FORCE_Z); -NODES[4274].Fix(BODY_FORCE_X); -NODES[4274].Fix(BODY_FORCE_Y); -NODES[4274].Fix(BODY_FORCE_Z); -NODES[4275].Fix(BODY_FORCE_X); -NODES[4275].Fix(BODY_FORCE_Y); -NODES[4275].Fix(BODY_FORCE_Z); -NODES[4276].Fix(BODY_FORCE_X); -NODES[4276].Fix(BODY_FORCE_Y); -NODES[4276].Fix(BODY_FORCE_Z); -NODES[4277].Fix(BODY_FORCE_X); -NODES[4277].Fix(BODY_FORCE_Y); -NODES[4277].Fix(BODY_FORCE_Z); -NODES[4278].Fix(BODY_FORCE_X); -NODES[4278].Fix(BODY_FORCE_Y); -NODES[4278].Fix(BODY_FORCE_Z); -NODES[4279].Fix(BODY_FORCE_X); -NODES[4279].Fix(BODY_FORCE_Y); -NODES[4279].Fix(BODY_FORCE_Z); -NODES[4280].Fix(BODY_FORCE_X); -NODES[4280].Fix(BODY_FORCE_Y); -NODES[4280].Fix(BODY_FORCE_Z); -NODES[4281].Fix(BODY_FORCE_X); -NODES[4281].Fix(BODY_FORCE_Y); -NODES[4281].Fix(BODY_FORCE_Z); -NODES[4282].Fix(BODY_FORCE_X); -NODES[4282].Fix(BODY_FORCE_Y); -NODES[4282].Fix(BODY_FORCE_Z); -NODES[4283].Fix(BODY_FORCE_X); -NODES[4283].Fix(BODY_FORCE_Y); -NODES[4283].Fix(BODY_FORCE_Z); -NODES[4284].Fix(BODY_FORCE_X); -NODES[4284].Fix(BODY_FORCE_Y); -NODES[4284].Fix(BODY_FORCE_Z); -NODES[4285].Fix(BODY_FORCE_X); -NODES[4285].Fix(BODY_FORCE_Y); -NODES[4285].Fix(BODY_FORCE_Z); -NODES[4286].Fix(BODY_FORCE_X); -NODES[4286].Fix(BODY_FORCE_Y); -NODES[4286].Fix(BODY_FORCE_Z); -NODES[4287].Fix(BODY_FORCE_X); -NODES[4287].Fix(BODY_FORCE_Y); -NODES[4287].Fix(BODY_FORCE_Z); -NODES[4288].Fix(BODY_FORCE_X); -NODES[4288].Fix(BODY_FORCE_Y); -NODES[4288].Fix(BODY_FORCE_Z); -NODES[4289].Fix(BODY_FORCE_X); -NODES[4289].Fix(BODY_FORCE_Y); -NODES[4289].Fix(BODY_FORCE_Z); -NODES[4290].Fix(BODY_FORCE_X); -NODES[4290].Fix(BODY_FORCE_Y); -NODES[4290].Fix(BODY_FORCE_Z); -NODES[4291].Fix(BODY_FORCE_X); -NODES[4291].Fix(BODY_FORCE_Y); -NODES[4291].Fix(BODY_FORCE_Z); -NODES[4292].Fix(BODY_FORCE_X); -NODES[4292].Fix(BODY_FORCE_Y); -NODES[4292].Fix(BODY_FORCE_Z); -NODES[4293].Fix(BODY_FORCE_X); -NODES[4293].Fix(BODY_FORCE_Y); -NODES[4293].Fix(BODY_FORCE_Z); -NODES[4294].Fix(BODY_FORCE_X); -NODES[4294].Fix(BODY_FORCE_Y); -NODES[4294].Fix(BODY_FORCE_Z); -NODES[4295].Fix(BODY_FORCE_X); -NODES[4295].Fix(BODY_FORCE_Y); -NODES[4295].Fix(BODY_FORCE_Z); -NODES[4296].Fix(BODY_FORCE_X); -NODES[4296].Fix(BODY_FORCE_Y); -NODES[4296].Fix(BODY_FORCE_Z); -NODES[4297].Fix(BODY_FORCE_X); -NODES[4297].Fix(BODY_FORCE_Y); -NODES[4297].Fix(BODY_FORCE_Z); -NODES[4298].Fix(BODY_FORCE_X); -NODES[4298].Fix(BODY_FORCE_Y); -NODES[4298].Fix(BODY_FORCE_Z); -NODES[4299].Fix(BODY_FORCE_X); -NODES[4299].Fix(BODY_FORCE_Y); -NODES[4299].Fix(BODY_FORCE_Z); diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.dat b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.dat deleted file mode 100644 index cd1cd61ef19d..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.dat +++ /dev/null @@ -1 +0,0 @@ -Write comments and documentation diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.elem b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.elem deleted file mode 100644 index d6359b1232e1..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.elem +++ /dev/null @@ -1,7512 +0,0 @@ -// Reading Elements - -ElementsGroup = fluid_group; - -ELEMENTS[1] = Fluid2D([1048,983,1049],1); -ELEMENTS[2] = Fluid2D([4284,4289,4280],1); -ELEMENTS[3] = Fluid2D([228,202,215],1); -ELEMENTS[4] = Fluid2D([557,505,533],1); -ELEMENTS[5] = Fluid2D([4234,4242,4221],1); -ELEMENTS[6] = Fluid2D([4196,4207,4181],1); -ELEMENTS[7] = Fluid2D([4296,4298,4294],1); -ELEMENTS[8] = Fluid2D([781,721,752],1); -ELEMENTS[9] = Fluid2D([371,329,351],1); -ELEMENTS[10] = Fluid2D([4263,4270,4256],1); -ELEMENTS[11] = Fluid2D([181,167,168],1); -ELEMENTS[12] = Fluid2D([4292,4295,4288],1); -ELEMENTS[13] = Fluid2D([912,845,880],1); -ELEMENTS[14] = Fluid2D([462,414,439],1); -ELEMENTS[15] = Fluid2D([4248,4257,4239],1); -ELEMENTS[16] = Fluid2D([4214,4226,4200],1); -ELEMENTS[17] = Fluid2D([4275,4281,4269],1); -ELEMENTS[18] = Fluid2D([291,257,274],1); -ELEMENTS[19] = Fluid2D([663,607,634],1); -ELEMENTS[20] = Fluid2D([983,912,949],1); -ELEMENTS[21] = Fluid2D([202,181,193],1); -ELEMENTS[22] = Fluid2D([4289,4292,4283],1); -ELEMENTS[23] = Fluid2D([4242,4248,4231],1); -ELEMENTS[24] = Fluid2D([505,462,486],1); -ELEMENTS[25] = Fluid2D([4298,4299,4297],1); -ELEMENTS[26] = Fluid2D([721,663,689],1); -ELEMENTS[27] = Fluid2D([4207,4214,4191],1); -ELEMENTS[28] = Fluid2D([329,291,312],1); -ELEMENTS[29] = Fluid2D([4270,4275,4262],1); -ELEMENTS[30] = Fluid2D([845,781,815],1); -ELEMENTS[31] = Fluid2D([4186,4196,4160],1); -ELEMENTS[32] = Fluid2D([4295,4296,4290],1); -ELEMENTS[33] = Fluid2D([414,371,393],1); -ELEMENTS[34] = Fluid2D([4257,4263,4247],1); -ELEMENTS[35] = Fluid2D([257,228,242],1); -ELEMENTS[36] = Fluid2D([607,557,580],1); -ELEMENTS[37] = Fluid2D([4281,4284,4274],1); -ELEMENTS[38] = Fluid2D([4226,4234,4211],1); -ELEMENTS[39] = Fluid2D([634,607,580],1); -ELEMENTS[40] = Fluid2D([634,580,608],1); -ELEMENTS[41] = Fluid2D([608,580,556],1); -ELEMENTS[42] = Fluid2D([4274,4284,4280],1); -ELEMENTS[43] = Fluid2D([4274,4280,4267],1); -ELEMENTS[44] = Fluid2D([4280,4289,4283],1); -ELEMENTS[45] = Fluid2D([4280,4283,4273],1); -ELEMENTS[46] = Fluid2D([4280,4273,4267],1); -ELEMENTS[47] = Fluid2D([4267,4273,4260],1); -ELEMENTS[48] = Fluid2D([4260,4273,4265],1); -ELEMENTS[49] = Fluid2D([4267,4260,4252],1); -ELEMENTS[50] = Fluid2D([4274,4267,4261],1); -ELEMENTS[51] = Fluid2D([312,291,274],1); -ELEMENTS[52] = Fluid2D([312,274,292],1); -ELEMENTS[53] = Fluid2D([292,274,256],1); -ELEMENTS[54] = Fluid2D([312,292,331],1); -ELEMENTS[55] = Fluid2D([4256,4270,4262],1); -ELEMENTS[56] = Fluid2D([4256,4262,4246],1); -ELEMENTS[57] = Fluid2D([4256,4246,4237],1); -ELEMENTS[58] = Fluid2D([4246,4262,4254],1); -ELEMENTS[59] = Fluid2D([4181,4207,4191],1); -ELEMENTS[60] = Fluid2D([4181,4191,4165],1); -ELEMENTS[61] = Fluid2D([4181,4165,4153],1); -ELEMENTS[62] = Fluid2D([4165,4191,4175],1); -ELEMENTS[63] = Fluid2D([393,371,351],1); -ELEMENTS[64] = Fluid2D([393,351,372],1); -ELEMENTS[65] = Fluid2D([393,372,415],1); -ELEMENTS[66] = Fluid2D([372,351,331],1); -ELEMENTS[67] = Fluid2D([372,331,352],1); -ELEMENTS[68] = Fluid2D([331,351,312],1); -ELEMENTS[69] = Fluid2D([312,351,329],1); -ELEMENTS[70] = Fluid2D([372,352,396],1); -ELEMENTS[71] = Fluid2D([352,331,313],1); -ELEMENTS[72] = Fluid2D([4239,4257,4247],1); -ELEMENTS[73] = Fluid2D([4239,4247,4230],1); -ELEMENTS[74] = Fluid2D([4230,4247,4237],1); -ELEMENTS[75] = Fluid2D([4230,4237,4217],1); -ELEMENTS[76] = Fluid2D([4237,4247,4256],1); -ELEMENTS[77] = Fluid2D([4256,4247,4263],1); -ELEMENTS[78] = Fluid2D([4217,4237,4228],1); -ELEMENTS[79] = Fluid2D([4230,4217,4209],1); -ELEMENTS[80] = Fluid2D([4239,4230,4220],1); -ELEMENTS[81] = Fluid2D([4231,4248,4239],1); -ELEMENTS[82] = Fluid2D([4231,4239,4220],1); -ELEMENTS[83] = Fluid2D([4231,4220,4210],1); -ELEMENTS[84] = Fluid2D([4210,4220,4197],1); -ELEMENTS[85] = Fluid2D([4231,4210,4221],1); -ELEMENTS[86] = Fluid2D([4221,4210,4199],1); -ELEMENTS[87] = Fluid2D([4231,4221,4242],1); -ELEMENTS[88] = Fluid2D([4199,4210,4185],1); -ELEMENTS[89] = Fluid2D([4221,4199,4211],1); -ELEMENTS[90] = Fluid2D([4211,4199,4187],1); -ELEMENTS[91] = Fluid2D([4221,4211,4234],1); -ELEMENTS[92] = Fluid2D([4211,4187,4200],1); -ELEMENTS[93] = Fluid2D([4200,4187,4175],1); -ELEMENTS[94] = Fluid2D([4175,4187,4161],1); -ELEMENTS[95] = Fluid2D([4161,4187,4174],1); -ELEMENTS[96] = Fluid2D([4175,4161,4147],1); -ELEMENTS[97] = Fluid2D([4211,4200,4226],1); -ELEMENTS[98] = Fluid2D([4200,4175,4191],1); -ELEMENTS[99] = Fluid2D([4200,4191,4214],1); -ELEMENTS[100] = Fluid2D([4187,4199,4174],1); -ELEMENTS[101] = Fluid2D([4174,4199,4185],1); -ELEMENTS[102] = Fluid2D([4174,4185,4158],1); -ELEMENTS[103] = Fluid2D([4158,4185,4171],1); -ELEMENTS[104] = Fluid2D([4174,4158,4146],1); -ELEMENTS[105] = Fluid2D([4146,4158,4129],1); -ELEMENTS[106] = Fluid2D([4174,4146,4161],1); -ELEMENTS[107] = Fluid2D([4161,4146,4137],1); -ELEMENTS[108] = Fluid2D([4161,4137,4147],1); -ELEMENTS[109] = Fluid2D([4147,4137,4121],1); -ELEMENTS[110] = Fluid2D([4137,4146,4120],1); -ELEMENTS[111] = Fluid2D([4121,4137,4107],1); -ELEMENTS[112] = Fluid2D([4147,4121,4136],1); -ELEMENTS[113] = Fluid2D([4137,4120,4107],1); -ELEMENTS[114] = Fluid2D([4107,4120,4092],1); -ELEMENTS[115] = Fluid2D([4120,4146,4129],1); -ELEMENTS[116] = Fluid2D([4120,4129,4103],1); -ELEMENTS[117] = Fluid2D([4103,4129,4117],1); -ELEMENTS[118] = Fluid2D([4120,4103,4092],1); -ELEMENTS[119] = Fluid2D([4092,4103,4077],1); -ELEMENTS[120] = Fluid2D([4092,4077,4066],1); -ELEMENTS[121] = Fluid2D([4077,4103,4091],1); -ELEMENTS[122] = Fluid2D([4117,4129,4145],1); -ELEMENTS[123] = Fluid2D([4066,4077,4050],1); -ELEMENTS[124] = Fluid2D([4091,4103,4117],1); -ELEMENTS[125] = Fluid2D([4091,4117,4104],1); -ELEMENTS[126] = Fluid2D([4104,4117,4130],1); -ELEMENTS[127] = Fluid2D([4091,4104,4075],1); -ELEMENTS[128] = Fluid2D([4092,4066,4080],1); -ELEMENTS[129] = Fluid2D([4077,4091,4064],1); -ELEMENTS[130] = Fluid2D([4136,4121,4113],1); -ELEMENTS[131] = Fluid2D([4107,4092,4080],1); -ELEMENTS[132] = Fluid2D([4107,4080,4098],1); -ELEMENTS[133] = Fluid2D([4107,4098,4121],1); -ELEMENTS[134] = Fluid2D([4121,4098,4113],1); -ELEMENTS[135] = Fluid2D([4098,4080,4070],1); -ELEMENTS[136] = Fluid2D([4113,4098,4083],1); -ELEMENTS[137] = Fluid2D([4070,4080,4054],1); -ELEMENTS[138] = Fluid2D([4098,4070,4083],1); -ELEMENTS[139] = Fluid2D([4171,4185,4197],1); -ELEMENTS[140] = Fluid2D([4197,4185,4210],1); -ELEMENTS[141] = Fluid2D([4147,4136,4165],1); -ELEMENTS[142] = Fluid2D([4165,4136,4153],1); -ELEMENTS[143] = Fluid2D([4153,4136,4133],1); -ELEMENTS[144] = Fluid2D([4147,4165,4175],1); -ELEMENTS[145] = Fluid2D([4158,4171,4145],1); -ELEMENTS[146] = Fluid2D([4158,4145,4129],1); -ELEMENTS[147] = Fluid2D([4145,4156,4130],1); -ELEMENTS[148] = Fluid2D([4145,4130,4117],1); -ELEMENTS[149] = Fluid2D([4091,4075,4064],1); -ELEMENTS[150] = Fluid2D([4064,4075,4048],1); -ELEMENTS[151] = Fluid2D([4048,4075,4063],1); -ELEMENTS[152] = Fluid2D([4064,4048,4036],1); -ELEMENTS[153] = Fluid2D([4075,4104,4090],1); -ELEMENTS[154] = Fluid2D([4104,4130,4119],1); -ELEMENTS[155] = Fluid2D([193,181,168],1); -ELEMENTS[156] = Fluid2D([533,505,486],1); -ELEMENTS[157] = Fluid2D([533,486,508],1); -ELEMENTS[158] = Fluid2D([508,486,461],1); -ELEMENTS[159] = Fluid2D([533,508,556],1); -ELEMENTS[160] = Fluid2D([556,508,534],1); -ELEMENTS[161] = Fluid2D([533,556,580],1); -ELEMENTS[162] = Fluid2D([533,580,557],1); -ELEMENTS[163] = Fluid2D([556,534,582],1); -ELEMENTS[164] = Fluid2D([534,508,487],1); -ELEMENTS[165] = Fluid2D([815,781,752],1); -ELEMENTS[166] = Fluid2D([815,752,783],1); -ELEMENTS[167] = Fluid2D([815,783,847],1); -ELEMENTS[168] = Fluid2D([783,752,719],1); -ELEMENTS[169] = Fluid2D([880,845,815],1); -ELEMENTS[170] = Fluid2D([880,815,847],1); -ELEMENTS[171] = Fluid2D([880,847,917],1); -ELEMENTS[172] = Fluid2D([880,917,949],1); -ELEMENTS[173] = Fluid2D([949,917,986],1); -ELEMENTS[174] = Fluid2D([880,949,912],1); -ELEMENTS[175] = Fluid2D([986,917,970],1); -ELEMENTS[176] = Fluid2D([949,986,1049],1); -ELEMENTS[177] = Fluid2D([917,847,884],1); -ELEMENTS[178] = Fluid2D([242,228,215],1); -ELEMENTS[179] = Fluid2D([242,215,229],1); -ELEMENTS[180] = Fluid2D([229,215,201],1); -ELEMENTS[181] = Fluid2D([242,229,256],1); -ELEMENTS[182] = Fluid2D([256,229,244],1); -ELEMENTS[183] = Fluid2D([242,256,274],1); -ELEMENTS[184] = Fluid2D([242,274,257],1); -ELEMENTS[185] = Fluid2D([256,244,278],1); -ELEMENTS[186] = Fluid2D([244,229,216],1); -ELEMENTS[187] = Fluid2D([752,721,689],1); -ELEMENTS[188] = Fluid2D([752,689,719],1); -ELEMENTS[189] = Fluid2D([719,689,659],1); -ELEMENTS[190] = Fluid2D([659,689,634],1); -ELEMENTS[191] = Fluid2D([659,634,608],1); -ELEMENTS[192] = Fluid2D([659,608,636],1); -ELEMENTS[193] = Fluid2D([634,689,663],1); -ELEMENTS[194] = Fluid2D([659,636,694],1); -ELEMENTS[195] = Fluid2D([636,608,582],1); -ELEMENTS[196] = Fluid2D([636,582,609],1); -ELEMENTS[197] = Fluid2D([582,608,556],1); -ELEMENTS[198] = Fluid2D([609,582,559],1); -ELEMENTS[199] = Fluid2D([636,609,666],1); -ELEMENTS[200] = Fluid2D([719,659,694],1); -ELEMENTS[201] = Fluid2D([719,694,755],1); -ELEMENTS[202] = Fluid2D([719,755,783],1); -ELEMENTS[203] = Fluid2D([783,755,817],1); -ELEMENTS[204] = Fluid2D([755,694,725],1); -ELEMENTS[205] = Fluid2D([817,755,787],1); -ELEMENTS[206] = Fluid2D([783,817,847],1); -ELEMENTS[207] = Fluid2D([847,817,884],1); -ELEMENTS[208] = Fluid2D([884,817,853],1); -ELEMENTS[209] = Fluid2D([725,694,666],1); -ELEMENTS[210] = Fluid2D([725,666,701],1); -ELEMENTS[211] = Fluid2D([701,666,642],1); -ELEMENTS[212] = Fluid2D([694,636,666],1); -ELEMENTS[213] = Fluid2D([817,787,853],1); -ELEMENTS[214] = Fluid2D([853,787,821],1); -ELEMENTS[215] = Fluid2D([755,725,787],1); -ELEMENTS[216] = Fluid2D([787,725,759],1); -ELEMENTS[217] = Fluid2D([759,725,701],1); -ELEMENTS[218] = Fluid2D([759,701,732],1); -ELEMENTS[219] = Fluid2D([732,701,672],1); -ELEMENTS[220] = Fluid2D([759,732,794],1); -ELEMENTS[221] = Fluid2D([787,759,821],1); -ELEMENTS[222] = Fluid2D([821,759,794],1); -ELEMENTS[223] = Fluid2D([821,794,858],1); -ELEMENTS[224] = Fluid2D([858,794,828],1); -ELEMENTS[225] = Fluid2D([821,858,885],1); -ELEMENTS[226] = Fluid2D([828,794,764],1); -ELEMENTS[227] = Fluid2D([732,672,704],1); -ELEMENTS[228] = Fluid2D([672,701,642],1); -ELEMENTS[229] = Fluid2D([672,642,617],1); -ELEMENTS[230] = Fluid2D([617,642,585],1); -ELEMENTS[231] = Fluid2D([672,617,647],1); -ELEMENTS[232] = Fluid2D([885,858,926],1); -ELEMENTS[233] = Fluid2D([884,853,920],1); -ELEMENTS[234] = Fluid2D([4269,4281,4274],1); -ELEMENTS[235] = Fluid2D([4269,4274,4261],1); -ELEMENTS[236] = Fluid2D([4269,4261,4254],1); -ELEMENTS[237] = Fluid2D([4254,4261,4244],1); -ELEMENTS[238] = Fluid2D([4269,4254,4262],1); -ELEMENTS[239] = Fluid2D([4269,4262,4275],1); -ELEMENTS[240] = Fluid2D([4254,4244,4236],1); -ELEMENTS[241] = Fluid2D([4244,4261,4252],1); -ELEMENTS[242] = Fluid2D([4244,4252,4235],1); -ELEMENTS[243] = Fluid2D([4235,4252,4238],1); -ELEMENTS[244] = Fluid2D([4244,4235,4227],1); -ELEMENTS[245] = Fluid2D([4252,4261,4267],1); -ELEMENTS[246] = Fluid2D([4236,4244,4227],1); -ELEMENTS[247] = Fluid2D([4236,4227,4213],1); -ELEMENTS[248] = Fluid2D([4254,4236,4246],1); -ELEMENTS[249] = Fluid2D([4246,4236,4228],1); -ELEMENTS[250] = Fluid2D([4228,4236,4213],1); -ELEMENTS[251] = Fluid2D([4228,4213,4206],1); -ELEMENTS[252] = Fluid2D([4246,4228,4237],1); -ELEMENTS[253] = Fluid2D([4206,4213,4190],1); -ELEMENTS[254] = Fluid2D([4228,4206,4217],1); -ELEMENTS[255] = Fluid2D([4217,4206,4194],1); -ELEMENTS[256] = Fluid2D([4217,4194,4209],1); -ELEMENTS[257] = Fluid2D([4209,4194,4184],1); -ELEMENTS[258] = Fluid2D([4194,4206,4179],1); -ELEMENTS[259] = Fluid2D([4184,4194,4169],1); -ELEMENTS[260] = Fluid2D([4209,4184,4197],1); -ELEMENTS[261] = Fluid2D([4197,4184,4171],1); -ELEMENTS[262] = Fluid2D([4171,4184,4156],1); -ELEMENTS[263] = Fluid2D([4179,4206,4190],1); -ELEMENTS[264] = Fluid2D([4179,4190,4164],1); -ELEMENTS[265] = Fluid2D([4179,4164,4152],1); -ELEMENTS[266] = Fluid2D([4164,4190,4177],1); -ELEMENTS[267] = Fluid2D([4156,4184,4169],1); -ELEMENTS[268] = Fluid2D([4156,4169,4141],1); -ELEMENTS[269] = Fluid2D([4141,4169,4152],1); -ELEMENTS[270] = Fluid2D([4141,4152,4126],1); -ELEMENTS[271] = Fluid2D([4152,4169,4179],1); -ELEMENTS[272] = Fluid2D([4141,4126,4119],1); -ELEMENTS[273] = Fluid2D([4141,4119,4130],1); -ELEMENTS[274] = Fluid2D([4126,4152,4143],1); -ELEMENTS[275] = Fluid2D([4179,4169,4194],1); -ELEMENTS[276] = Fluid2D([4156,4141,4130],1); -ELEMENTS[277] = Fluid2D([4156,4145,4171],1); -ELEMENTS[278] = Fluid2D([4126,4143,4114],1); -ELEMENTS[279] = Fluid2D([4143,4152,4164],1); -ELEMENTS[280] = Fluid2D([4143,4164,4150],1); -ELEMENTS[281] = Fluid2D([4150,4164,4177],1); -ELEMENTS[282] = Fluid2D([4150,4177,4166],1); -ELEMENTS[283] = Fluid2D([4143,4150,4124],1); -ELEMENTS[284] = Fluid2D([4150,4166,4138],1); -ELEMENTS[285] = Fluid2D([4166,4177,4192],1); -ELEMENTS[286] = Fluid2D([4143,4124,4114],1); -ELEMENTS[287] = Fluid2D([4114,4124,4096],1); -ELEMENTS[288] = Fluid2D([4114,4096,4085],1); -ELEMENTS[289] = Fluid2D([4096,4124,4111],1); -ELEMENTS[290] = Fluid2D([4124,4150,4138],1); -ELEMENTS[291] = Fluid2D([4124,4138,4111],1); -ELEMENTS[292] = Fluid2D([4111,4138,4125],1); -ELEMENTS[293] = Fluid2D([4125,4138,4151],1); -ELEMENTS[294] = Fluid2D([4111,4125,4095],1); -ELEMENTS[295] = Fluid2D([4096,4111,4082],1); -ELEMENTS[296] = Fluid2D([4114,4085,4100],1); -ELEMENTS[297] = Fluid2D([4085,4096,4068],1); -ELEMENTS[298] = Fluid2D([4125,4151,4142],1); -ELEMENTS[299] = Fluid2D([4192,4177,4203],1); -ELEMENTS[300] = Fluid2D([4138,4166,4151],1); -ELEMENTS[301] = Fluid2D([4151,4166,4178],1); -ELEMENTS[302] = Fluid2D([4178,4166,4192],1); -ELEMENTS[303] = Fluid2D([4178,4192,4204],1); -ELEMENTS[304] = Fluid2D([4151,4178,4167],1); -ELEMENTS[305] = Fluid2D([4204,4192,4215],1); -ELEMENTS[306] = Fluid2D([4178,4204,4193],1); -ELEMENTS[307] = Fluid2D([4167,4178,4193],1); -ELEMENTS[308] = Fluid2D([4151,4167,4142],1); -ELEMENTS[309] = Fluid2D([4142,4167,4154],1); -ELEMENTS[310] = Fluid2D([4154,4167,4182],1); -ELEMENTS[311] = Fluid2D([4142,4154,4127],1); -ELEMENTS[312] = Fluid2D([4154,4182,4170],1); -ELEMENTS[313] = Fluid2D([4182,4167,4193],1); -ELEMENTS[314] = Fluid2D([4182,4193,4208],1); -ELEMENTS[315] = Fluid2D([4208,4193,4216],1); -ELEMENTS[316] = Fluid2D([4182,4208,4195],1); -ELEMENTS[317] = Fluid2D([4142,4127,4112],1); -ELEMENTS[318] = Fluid2D([4190,4213,4203],1); -ELEMENTS[319] = Fluid2D([4203,4213,4227],1); -ELEMENTS[320] = Fluid2D([4203,4227,4215],1); -ELEMENTS[321] = Fluid2D([4215,4227,4235],1); -ELEMENTS[322] = Fluid2D([4215,4235,4224],1); -ELEMENTS[323] = Fluid2D([4190,4203,4177],1); -ELEMENTS[324] = Fluid2D([4224,4235,4238],1); -ELEMENTS[325] = Fluid2D([4215,4224,4204],1); -ELEMENTS[326] = Fluid2D([4204,4224,4216],1); -ELEMENTS[327] = Fluid2D([4216,4224,4238],1); -ELEMENTS[328] = Fluid2D([4204,4216,4193],1); -ELEMENTS[329] = Fluid2D([4203,4215,4192],1); -ELEMENTS[330] = Fluid2D([4111,4095,4082],1); -ELEMENTS[331] = Fluid2D([4082,4095,4069],1); -ELEMENTS[332] = Fluid2D([4069,4095,4084],1); -ELEMENTS[333] = Fluid2D([4082,4069,4056],1); -ELEMENTS[334] = Fluid2D([4084,4095,4112],1); -ELEMENTS[335] = Fluid2D([4112,4095,4125],1); -ELEMENTS[336] = Fluid2D([4112,4125,4142],1); -ELEMENTS[337] = Fluid2D([4084,4112,4099],1); -ELEMENTS[338] = Fluid2D([4069,4084,4052],1); -ELEMENTS[339] = Fluid2D([4082,4056,4068],1); -ELEMENTS[340] = Fluid2D([4068,4056,4042],1); -ELEMENTS[341] = Fluid2D([4056,4069,4043],1); -ELEMENTS[342] = Fluid2D([4127,4154,4135],1); -ELEMENTS[343] = Fluid2D([215,202,193],1); -ELEMENTS[344] = Fluid2D([215,193,201],1); -ELEMENTS[345] = Fluid2D([201,193,180],1); -ELEMENTS[346] = Fluid2D([201,180,188],1); -ELEMENTS[347] = Fluid2D([180,193,168],1); -ELEMENTS[348] = Fluid2D([4288,4295,4290],1); -ELEMENTS[349] = Fluid2D([4288,4290,4282],1); -ELEMENTS[350] = Fluid2D([4282,4290,4287],1); -ELEMENTS[351] = Fluid2D([4288,4282,4278],1); -ELEMENTS[352] = Fluid2D([4294,4298,4297],1); -ELEMENTS[353] = Fluid2D([486,462,439],1); -ELEMENTS[354] = Fluid2D([486,439,461],1); -ELEMENTS[355] = Fluid2D([461,439,415],1); -ELEMENTS[356] = Fluid2D([461,415,440],1); -ELEMENTS[357] = Fluid2D([415,439,393],1); -ELEMENTS[358] = Fluid2D([393,439,414],1); -ELEMENTS[359] = Fluid2D([440,415,396],1); -ELEMENTS[360] = Fluid2D([440,396,420],1); -ELEMENTS[361] = Fluid2D([461,440,487],1); -ELEMENTS[362] = Fluid2D([487,440,465],1); -ELEMENTS[363] = Fluid2D([465,440,420],1); -ELEMENTS[364] = Fluid2D([465,420,445],1); -ELEMENTS[365] = Fluid2D([445,420,397],1); -ELEMENTS[366] = Fluid2D([465,445,492],1); -ELEMENTS[367] = Fluid2D([396,415,372],1); -ELEMENTS[368] = Fluid2D([487,465,511],1); -ELEMENTS[369] = Fluid2D([420,396,375],1); -ELEMENTS[370] = Fluid2D([461,487,508],1); -ELEMENTS[371] = Fluid2D([4283,4292,4288],1); -ELEMENTS[372] = Fluid2D([4283,4288,4278],1); -ELEMENTS[373] = Fluid2D([4283,4278,4273],1); -ELEMENTS[374] = Fluid2D([4273,4278,4265],1); -ELEMENTS[375] = Fluid2D([4265,4278,4272],1); -ELEMENTS[376] = Fluid2D([4265,4272,4258],1); -ELEMENTS[377] = Fluid2D([4272,4278,4282],1); -ELEMENTS[378] = Fluid2D([4272,4282,4279],1); -ELEMENTS[379] = Fluid2D([4279,4282,4287],1); -ELEMENTS[380] = Fluid2D([4279,4287,4285],1); -ELEMENTS[381] = Fluid2D([4272,4279,4264],1); -ELEMENTS[382] = Fluid2D([4279,4285,4271],1); -ELEMENTS[383] = Fluid2D([4285,4287,4291],1); -ELEMENTS[384] = Fluid2D([4272,4264,4258],1); -ELEMENTS[385] = Fluid2D([4258,4264,4249],1); -ELEMENTS[386] = Fluid2D([4258,4249,4245],1); -ELEMENTS[387] = Fluid2D([4249,4264,4259],1); -ELEMENTS[388] = Fluid2D([4264,4279,4271],1); -ELEMENTS[389] = Fluid2D([4264,4271,4259],1); -ELEMENTS[390] = Fluid2D([4259,4271,4266],1); -ELEMENTS[391] = Fluid2D([4259,4266,4250],1); -ELEMENTS[392] = Fluid2D([4266,4271,4277],1); -ELEMENTS[393] = Fluid2D([4290,4296,4294],1); -ELEMENTS[394] = Fluid2D([4290,4294,4287],1); -ELEMENTS[395] = Fluid2D([4287,4294,4291],1); -ELEMENTS[396] = Fluid2D([4291,4294,4297],1); -ELEMENTS[397] = Fluid2D([4196,4181,4160],1); -ELEMENTS[398] = Fluid2D([858,828,895],1); -ELEMENTS[399] = Fluid2D([4209,4197,4220],1); -ELEMENTS[400] = Fluid2D([4209,4220,4230],1); -ELEMENTS[401] = Fluid2D([983,949,1049],1); -ELEMENTS[402] = Fluid2D([821,885,853],1); -ELEMENTS[403] = Fluid2D([853,885,920],1); -ELEMENTS[404] = Fluid2D([920,885,962],1); -ELEMENTS[405] = Fluid2D([962,885,926],1); -ELEMENTS[406] = Fluid2D([962,926,994],1); -ELEMENTS[407] = Fluid2D([962,994,1057],1); -ELEMENTS[408] = Fluid2D([994,926,961],1); -ELEMENTS[409] = Fluid2D([920,962,991],1); -ELEMENTS[410] = Fluid2D([961,926,895],1); -ELEMENTS[411] = Fluid2D([961,895,931],1); -ELEMENTS[412] = Fluid2D([931,895,861],1); -ELEMENTS[413] = Fluid2D([961,931,1001],1); -ELEMENTS[414] = Fluid2D([994,961,1062],1); -ELEMENTS[415] = Fluid2D([931,861,904],1); -ELEMENTS[416] = Fluid2D([961,1001,1062],1); -ELEMENTS[417] = Fluid2D([991,962,1057],1); -ELEMENTS[418] = Fluid2D([920,991,970],1); -ELEMENTS[419] = Fluid2D([861,895,828],1); -ELEMENTS[420] = Fluid2D([861,828,798],1); -ELEMENTS[421] = Fluid2D([798,828,764],1); -ELEMENTS[422] = Fluid2D([798,764,735],1); -ELEMENTS[423] = Fluid2D([861,798,838],1); -ELEMENTS[424] = Fluid2D([798,735,772],1); -ELEMENTS[425] = Fluid2D([735,764,704],1); -ELEMENTS[426] = Fluid2D([735,704,676],1); -ELEMENTS[427] = Fluid2D([735,676,712],1); -ELEMENTS[428] = Fluid2D([676,704,647],1); -ELEMENTS[429] = Fluid2D([647,704,672],1); -ELEMENTS[430] = Fluid2D([676,647,621],1); -ELEMENTS[431] = Fluid2D([676,621,651],1); -ELEMENTS[432] = Fluid2D([621,647,594],1); -ELEMENTS[433] = Fluid2D([1001,931,974],1); -ELEMENTS[434] = Fluid2D([794,732,764],1); -ELEMENTS[435] = Fluid2D([764,732,704],1); -ELEMENTS[436] = Fluid2D([4048,4063,4035],1); -ELEMENTS[437] = Fluid2D([617,585,562],1); -ELEMENTS[438] = Fluid2D([4266,4277,4276],1); -ELEMENTS[439] = Fluid2D([582,534,559],1); -ELEMENTS[440] = Fluid2D([559,534,511],1); -ELEMENTS[441] = Fluid2D([559,511,538],1); -ELEMENTS[442] = Fluid2D([511,534,487],1); -ELEMENTS[443] = Fluid2D([538,511,492],1); -ELEMENTS[444] = Fluid2D([538,492,516],1); -ELEMENTS[445] = Fluid2D([559,538,585],1); -ELEMENTS[446] = Fluid2D([585,538,562],1); -ELEMENTS[447] = Fluid2D([562,538,516],1); -ELEMENTS[448] = Fluid2D([562,516,541],1); -ELEMENTS[449] = Fluid2D([541,516,494],1); -ELEMENTS[450] = Fluid2D([562,541,594],1); -ELEMENTS[451] = Fluid2D([562,594,617],1); -ELEMENTS[452] = Fluid2D([617,594,647],1); -ELEMENTS[453] = Fluid2D([594,541,574],1); -ELEMENTS[454] = Fluid2D([516,492,469],1); -ELEMENTS[455] = Fluid2D([492,511,465],1); -ELEMENTS[456] = Fluid2D([541,494,521],1); -ELEMENTS[457] = Fluid2D([594,574,621],1); -ELEMENTS[458] = Fluid2D([621,574,600],1); -ELEMENTS[459] = Fluid2D([600,574,548],1); -ELEMENTS[460] = Fluid2D([621,600,651],1); -ELEMENTS[461] = Fluid2D([651,600,627],1); -ELEMENTS[462] = Fluid2D([651,627,685],1); -ELEMENTS[463] = Fluid2D([627,600,577],1); -ELEMENTS[464] = Fluid2D([600,548,577],1); -ELEMENTS[465] = Fluid2D([577,548,527],1); -ELEMENTS[466] = Fluid2D([548,574,521],1); -ELEMENTS[467] = Fluid2D([548,521,501],1); -ELEMENTS[468] = Fluid2D([548,501,527],1); -ELEMENTS[469] = Fluid2D([527,501,482],1); -ELEMENTS[470] = Fluid2D([482,501,454],1); -ELEMENTS[471] = Fluid2D([527,482,506],1); -ELEMENTS[472] = Fluid2D([501,521,472],1); -ELEMENTS[473] = Fluid2D([506,482,460],1); -ELEMENTS[474] = Fluid2D([454,501,472],1); -ELEMENTS[475] = Fluid2D([454,472,427],1); -ELEMENTS[476] = Fluid2D([454,427,406],1); -ELEMENTS[477] = Fluid2D([427,472,447],1); -ELEMENTS[478] = Fluid2D([454,406,435],1); -ELEMENTS[479] = Fluid2D([406,427,383],1); -ELEMENTS[480] = Fluid2D([685,627,664],1); -ELEMENTS[481] = Fluid2D([482,454,435],1); -ELEMENTS[482] = Fluid2D([482,435,460],1); -ELEMENTS[483] = Fluid2D([460,435,412],1); -ELEMENTS[484] = Fluid2D([577,527,553],1); -ELEMENTS[485] = Fluid2D([447,472,494],1); -ELEMENTS[486] = Fluid2D([447,494,469],1); -ELEMENTS[487] = Fluid2D([469,494,516],1); -ELEMENTS[488] = Fluid2D([527,506,553],1); -ELEMENTS[489] = Fluid2D([553,506,537],1); -ELEMENTS[490] = Fluid2D([553,537,584],1); -ELEMENTS[491] = Fluid2D([537,506,490],1); -ELEMENTS[492] = Fluid2D([490,506,460],1); -ELEMENTS[493] = Fluid2D([490,460,442],1); -ELEMENTS[494] = Fluid2D([442,460,412],1); -ELEMENTS[495] = Fluid2D([490,442,471],1); -ELEMENTS[496] = Fluid2D([584,537,568],1); -ELEMENTS[497] = Fluid2D([537,490,515],1); -ELEMENTS[498] = Fluid2D([471,442,426],1); -ELEMENTS[499] = Fluid2D([442,412,395],1); -ELEMENTS[500] = Fluid2D([553,584,603],1); -ELEMENTS[501] = Fluid2D([651,685,712],1); -ELEMENTS[502] = Fluid2D([712,685,747],1); -ELEMENTS[503] = Fluid2D([490,471,515],1); -ELEMENTS[504] = Fluid2D([515,471,498],1); -ELEMENTS[505] = Fluid2D([498,471,451],1); -ELEMENTS[506] = Fluid2D([515,498,546],1); -ELEMENTS[507] = Fluid2D([427,447,401],1); -ELEMENTS[508] = Fluid2D([627,577,603],1); -ELEMENTS[509] = Fluid2D([627,603,664],1); -ELEMENTS[510] = Fluid2D([603,577,553],1); -ELEMENTS[511] = Fluid2D([574,541,521],1); -ELEMENTS[512] = Fluid2D([469,492,445],1); -ELEMENTS[513] = Fluid2D([469,445,423],1); -ELEMENTS[514] = Fluid2D([423,445,397],1); -ELEMENTS[515] = Fluid2D([469,423,447],1); -ELEMENTS[516] = Fluid2D([447,423,401],1); -ELEMENTS[517] = Fluid2D([401,423,379],1); -ELEMENTS[518] = Fluid2D([379,423,397],1); -ELEMENTS[519] = Fluid2D([379,397,354],1); -ELEMENTS[520] = Fluid2D([354,397,375],1); -ELEMENTS[521] = Fluid2D([354,375,332],1); -ELEMENTS[522] = Fluid2D([379,354,336],1); -ELEMENTS[523] = Fluid2D([401,379,357],1); -ELEMENTS[524] = Fluid2D([375,397,420],1); -ELEMENTS[525] = Fluid2D([357,379,336],1); -ELEMENTS[526] = Fluid2D([357,336,318],1); -ELEMENTS[527] = Fluid2D([318,336,298],1); -ELEMENTS[528] = Fluid2D([357,318,341],1); -ELEMENTS[529] = Fluid2D([341,318,302],1); -ELEMENTS[530] = Fluid2D([537,515,568],1); -ELEMENTS[531] = Fluid2D([584,568,619],1); -ELEMENTS[532] = Fluid2D([521,494,472],1); -ELEMENTS[533] = Fluid2D([302,318,279],1); -ELEMENTS[534] = Fluid2D([4208,4216,4229],1); -ELEMENTS[535] = Fluid2D([4229,4216,4238],1); -ELEMENTS[536] = Fluid2D([4208,4229,4218],1); -ELEMENTS[537] = Fluid2D([546,498,530],1); -ELEMENTS[538] = Fluid2D([530,498,483],1); -ELEMENTS[539] = Fluid2D([546,530,579],1); -ELEMENTS[540] = Fluid2D([4075,4090,4063],1); -ELEMENTS[541] = Fluid2D([4063,4090,4076],1); -ELEMENTS[542] = Fluid2D([4063,4076,4049],1); -ELEMENTS[543] = Fluid2D([4076,4090,4100],1); -ELEMENTS[544] = Fluid2D([4076,4100,4085],1); -ELEMENTS[545] = Fluid2D([4076,4085,4057],1); -ELEMENTS[546] = Fluid2D([4057,4085,4068],1); -ELEMENTS[547] = Fluid2D([4076,4057,4049],1); -ELEMENTS[548] = Fluid2D([4049,4057,4031],1); -ELEMENTS[549] = Fluid2D([4031,4057,4042],1); -ELEMENTS[550] = Fluid2D([4049,4031,4023],1); -ELEMENTS[551] = Fluid2D([4049,4023,4035],1); -ELEMENTS[552] = Fluid2D([4035,4023,4011],1); -ELEMENTS[553] = Fluid2D([4035,4027,4048],1); -ELEMENTS[554] = Fluid2D([4011,4023,3996],1); -ELEMENTS[555] = Fluid2D([4049,4035,4063],1); -ELEMENTS[556] = Fluid2D([4011,3996,3980],1); -ELEMENTS[557] = Fluid2D([3996,4023,4008],1); -ELEMENTS[558] = Fluid2D([4023,4031,4008],1); -ELEMENTS[559] = Fluid2D([4008,4031,4017],1); -ELEMENTS[560] = Fluid2D([4017,4031,4042],1); -ELEMENTS[561] = Fluid2D([4017,4042,4025],1); -ELEMENTS[562] = Fluid2D([4008,4017,3991],1); -ELEMENTS[563] = Fluid2D([4017,4025,3998],1); -ELEMENTS[564] = Fluid2D([4025,4042,4056],1); -ELEMENTS[565] = Fluid2D([3991,4017,3998],1); -ELEMENTS[566] = Fluid2D([3991,3998,3972],1); -ELEMENTS[567] = Fluid2D([3972,3998,3979],1); -ELEMENTS[568] = Fluid2D([3991,3972,3963],1); -ELEMENTS[569] = Fluid2D([4008,3991,3981],1); -ELEMENTS[570] = Fluid2D([3972,3979,3954],1); -ELEMENTS[571] = Fluid2D([3991,3963,3981],1); -ELEMENTS[572] = Fluid2D([3981,3963,3962],1); -ELEMENTS[573] = Fluid2D([3962,3963,3937],1); -ELEMENTS[574] = Fluid2D([3981,3962,3996],1); -ELEMENTS[575] = Fluid2D([3937,3963,3947],1); -ELEMENTS[576] = Fluid2D([3962,3937,3929],1); -ELEMENTS[577] = Fluid2D([3979,3998,4006],1); -ELEMENTS[578] = Fluid2D([3963,3972,3947],1); -ELEMENTS[579] = Fluid2D([3947,3972,3954],1); -ELEMENTS[580] = Fluid2D([3947,3954,3927],1); -ELEMENTS[581] = Fluid2D([3998,4025,4006],1); -ELEMENTS[582] = Fluid2D([4006,4025,4043],1); -ELEMENTS[583] = Fluid2D([3947,3927,3922],1); -ELEMENTS[584] = Fluid2D([3927,3954,3934],1); -ELEMENTS[585] = Fluid2D([3996,4008,3981],1); -ELEMENTS[586] = Fluid2D([3996,3962,3980],1); -ELEMENTS[587] = Fluid2D([4011,3980,4000],1); -ELEMENTS[588] = Fluid2D([3979,4006,3989],1); -ELEMENTS[589] = Fluid2D([3937,3947,3922],1); -ELEMENTS[590] = Fluid2D([3937,3922,3910],1); -ELEMENTS[591] = Fluid2D([3910,3922,3891],1); -ELEMENTS[592] = Fluid2D([3937,3910,3929],1); -ELEMENTS[593] = Fluid2D([3929,3910,3903],1); -ELEMENTS[594] = Fluid2D([3903,3910,3883],1); -ELEMENTS[595] = Fluid2D([3929,3903,3925],1); -ELEMENTS[596] = Fluid2D([3891,3922,3904],1); -ELEMENTS[597] = Fluid2D([3925,3903,3897],1); -ELEMENTS[598] = Fluid2D([3883,3910,3891],1); -ELEMENTS[599] = Fluid2D([3883,3891,3860],1); -ELEMENTS[600] = Fluid2D([3860,3891,3877],1); -ELEMENTS[601] = Fluid2D([3883,3860,3854],1); -ELEMENTS[602] = Fluid2D([3903,3883,3876],1); -ELEMENTS[603] = Fluid2D([3929,3925,3951],1); -ELEMENTS[604] = Fluid2D([3891,3904,3877],1); -ELEMENTS[605] = Fluid2D([3877,3904,3885],1); -ELEMENTS[606] = Fluid2D([3877,3885,3859],1); -ELEMENTS[607] = Fluid2D([3885,3904,3911],1); -ELEMENTS[608] = Fluid2D([3934,3954,3960],1); -ELEMENTS[609] = Fluid2D([3877,3859,3849],1); -ELEMENTS[610] = Fluid2D([4000,3980,3970],1); -ELEMENTS[611] = Fluid2D([3989,4006,4018],1); -ELEMENTS[612] = Fluid2D([3960,3954,3979],1); -ELEMENTS[613] = Fluid2D([3849,3859,3830],1); -ELEMENTS[614] = Fluid2D([3904,3922,3927],1); -ELEMENTS[615] = Fluid2D([3904,3927,3911],1); -ELEMENTS[616] = Fluid2D([3911,3927,3934],1); -ELEMENTS[617] = Fluid2D([3911,3934,3913],1); -ELEMENTS[618] = Fluid2D([3911,3886,3885],1); -ELEMENTS[619] = Fluid2D([3913,3934,3941],1); -ELEMENTS[620] = Fluid2D([3941,3934,3960],1); -ELEMENTS[621] = Fluid2D([3941,3960,3969],1); -ELEMENTS[622] = Fluid2D([3969,3960,3989],1); -ELEMENTS[623] = Fluid2D([3941,3969,3948],1); -ELEMENTS[624] = Fluid2D([3913,3941,3924],1); -ELEMENTS[625] = Fluid2D([3941,3948,3924],1); -ELEMENTS[626] = Fluid2D([3924,3948,3928],1); -ELEMENTS[627] = Fluid2D([3928,3948,3955],1); -ELEMENTS[628] = Fluid2D([3924,3928,3902],1); -ELEMENTS[629] = Fluid2D([3948,3969,3974],1); -ELEMENTS[630] = Fluid2D([3955,3948,3974],1); -ELEMENTS[631] = Fluid2D([3955,3974,3982],1); -ELEMENTS[632] = Fluid2D([3982,3974,4001],1); -ELEMENTS[633] = Fluid2D([3955,3982,3961],1); -ELEMENTS[634] = Fluid2D([3902,3928,3908],1); -ELEMENTS[635] = Fluid2D([3924,3902,3895],1); -ELEMENTS[636] = Fluid2D([3928,3955,3936],1); -ELEMENTS[637] = Fluid2D([3913,3924,3895],1); -ELEMENTS[638] = Fluid2D([3913,3895,3886],1); -ELEMENTS[639] = Fluid2D([3886,3895,3868],1); -ELEMENTS[640] = Fluid2D([3913,3886,3911],1); -ELEMENTS[641] = Fluid2D([3885,3886,3859],1); -ELEMENTS[642] = Fluid2D([3961,3982,3988],1); -ELEMENTS[643] = Fluid2D([4001,3974,3993],1); -ELEMENTS[644] = Fluid2D([3974,3969,3993],1); -ELEMENTS[645] = Fluid2D([3993,3969,3989],1); -ELEMENTS[646] = Fluid2D([3902,3908,3880],1); -ELEMENTS[647] = Fluid2D([3988,3982,4010],1); -ELEMENTS[648] = Fluid2D([3982,4001,4010],1); -ELEMENTS[649] = Fluid2D([3955,3961,3936],1); -ELEMENTS[650] = Fluid2D([3936,3961,3946],1); -ELEMENTS[651] = Fluid2D([3946,3961,3971],1); -ELEMENTS[652] = Fluid2D([3936,3946,3914],1); -ELEMENTS[653] = Fluid2D([3946,3971,3953],1); -ELEMENTS[654] = Fluid2D([3971,3961,3988],1); -ELEMENTS[655] = Fluid2D([3971,3988,3999],1); -ELEMENTS[656] = Fluid2D([3971,3999,3978],1); -ELEMENTS[657] = Fluid2D([3999,3988,4016],1); -ELEMENTS[658] = Fluid2D([3914,3946,3926],1); -ELEMENTS[659] = Fluid2D([3971,3978,3953],1); -ELEMENTS[660] = Fluid2D([3953,3978,3959],1); -ELEMENTS[661] = Fluid2D([3953,3959,3933],1); -ELEMENTS[662] = Fluid2D([3959,3978,3987],1); -ELEMENTS[663] = Fluid2D([3987,3978,4004],1); -ELEMENTS[664] = Fluid2D([3933,3959,3940],1); -ELEMENTS[665] = Fluid2D([3946,3953,3926],1); -ELEMENTS[666] = Fluid2D([4004,3978,3999],1); -ELEMENTS[667] = Fluid2D([4004,3999,4026],1); -ELEMENTS[668] = Fluid2D([4004,4026,4032],1); -ELEMENTS[669] = Fluid2D([4026,3999,4016],1); -ELEMENTS[670] = Fluid2D([4026,4016,4045],1); -ELEMENTS[671] = Fluid2D([4032,4026,4051],1); -ELEMENTS[672] = Fluid2D([4026,4045,4051],1); -ELEMENTS[673] = Fluid2D([3940,3959,3966],1); -ELEMENTS[674] = Fluid2D([3953,3933,3926],1); -ELEMENTS[675] = Fluid2D([3926,3933,3901],1); -ELEMENTS[676] = Fluid2D([3901,3933,3915],1); -ELEMENTS[677] = Fluid2D([3926,3901,3899],1); -ELEMENTS[678] = Fluid2D([4004,4032,4013],1); -ELEMENTS[679] = Fluid2D([4013,4032,4041],1); -ELEMENTS[680] = Fluid2D([4004,4013,3987],1); -ELEMENTS[681] = Fluid2D([3987,4013,3994],1); -ELEMENTS[682] = Fluid2D([3987,3994,3966],1); -ELEMENTS[683] = Fluid2D([3994,4013,4020],1); -ELEMENTS[684] = Fluid2D([3966,3994,3975],1); -ELEMENTS[685] = Fluid2D([3994,4020,4002],1); -ELEMENTS[686] = Fluid2D([4020,4013,4041],1); -ELEMENTS[687] = Fluid2D([4020,4041,4046],1); -ELEMENTS[688] = Fluid2D([4046,4041,4067],1); -ELEMENTS[689] = Fluid2D([4020,4046,4029],1); -ELEMENTS[690] = Fluid2D([4067,4041,4058],1); -ELEMENTS[691] = Fluid2D([3966,3975,3949],1); -ELEMENTS[692] = Fluid2D([3994,4002,3975],1); -ELEMENTS[693] = Fluid2D([3975,4002,3983],1); -ELEMENTS[694] = Fluid2D([3983,4002,4012],1); -ELEMENTS[695] = Fluid2D([4012,4002,4029],1); -ELEMENTS[696] = Fluid2D([4012,4029,4038],1); -ELEMENTS[697] = Fluid2D([4029,4002,4020],1); -ELEMENTS[698] = Fluid2D([4038,4029,4060],1); -ELEMENTS[699] = Fluid2D([4012,4038,4019],1); -ELEMENTS[700] = Fluid2D([4019,4038,4039],1); -ELEMENTS[701] = Fluid2D([4019,4039,4015],1); -ELEMENTS[702] = Fluid2D([3983,4012,3992],1); -ELEMENTS[703] = Fluid2D([4058,4041,4032],1); -ELEMENTS[704] = Fluid2D([4058,4032,4051],1); -ELEMENTS[705] = Fluid2D([4058,4051,4078],1); -ELEMENTS[706] = Fluid2D([4078,4051,4071],1); -ELEMENTS[707] = Fluid2D([4058,4078,4088],1); -ELEMENTS[708] = Fluid2D([4071,4051,4045],1); -ELEMENTS[709] = Fluid2D([4078,4071,4097],1); -ELEMENTS[710] = Fluid2D([4088,4078,4105],1); -ELEMENTS[711] = Fluid2D([3975,3983,3956],1); -ELEMENTS[712] = Fluid2D([3956,3983,3964],1); -ELEMENTS[713] = Fluid2D([3975,3956,3949],1); -ELEMENTS[714] = Fluid2D([3949,3956,3930],1); -ELEMENTS[715] = Fluid2D([3930,3956,3938],1); -ELEMENTS[716] = Fluid2D([3949,3930,3921],1); -ELEMENTS[717] = Fluid2D([3921,3930,3896],1); -ELEMENTS[718] = Fluid2D([3938,3956,3964],1); -ELEMENTS[719] = Fluid2D([3938,3964,3943],1); -ELEMENTS[720] = Fluid2D([3938,3943,3918],1); -ELEMENTS[721] = Fluid2D([3943,3964,3973],1); -ELEMENTS[722] = Fluid2D([3949,3921,3940],1); -ELEMENTS[723] = Fluid2D([4060,4029,4046],1); -ELEMENTS[724] = Fluid2D([4060,4046,4073],1); -ELEMENTS[725] = Fluid2D([4073,4046,4067],1); -ELEMENTS[726] = Fluid2D([4073,4067,4093],1); -ELEMENTS[727] = Fluid2D([4060,4073,4081],1); -ELEMENTS[728] = Fluid2D([4093,4067,4088],1); -ELEMENTS[729] = Fluid2D([4093,4088,4115],1); -ELEMENTS[730] = Fluid2D([4088,4067,4058],1); -ELEMENTS[731] = Fluid2D([4115,4088,4105],1); -ELEMENTS[732] = Fluid2D([4115,4105,4131],1); -ELEMENTS[733] = Fluid2D([4131,4105,4123],1); -ELEMENTS[734] = Fluid2D([4115,4131,4140],1); -ELEMENTS[735] = Fluid2D([4093,4115,4122],1); -ELEMENTS[736] = Fluid2D([4073,4093,4102],1); -ELEMENTS[737] = Fluid2D([4115,4140,4122],1); -ELEMENTS[738] = Fluid2D([4122,4140,4157],1); -ELEMENTS[739] = Fluid2D([4131,4123,4148],1); -ELEMENTS[740] = Fluid2D([4123,4105,4097],1); -ELEMENTS[741] = Fluid2D([4123,4097,4116],1); -ELEMENTS[742] = Fluid2D([4116,4097,4089],1); -ELEMENTS[743] = Fluid2D([4123,4116,4144],1); -ELEMENTS[744] = Fluid2D([4140,4131,4159],1); -ELEMENTS[745] = Fluid2D([4093,4122,4102],1); -ELEMENTS[746] = Fluid2D([4060,4087,4061],1); -ELEMENTS[747] = Fluid2D([4081,4073,4102],1); -ELEMENTS[748] = Fluid2D([4081,4102,4109],1); -ELEMENTS[749] = Fluid2D([4081,4109,4087],1); -ELEMENTS[750] = Fluid2D([4081,4087,4060],1); -ELEMENTS[751] = Fluid2D([4148,4123,4144],1); -ELEMENTS[752] = Fluid2D([4148,4144,4172],1); -ELEMENTS[753] = Fluid2D([4172,4144,4162],1); -ELEMENTS[754] = Fluid2D([4148,4172,4176],1); -ELEMENTS[755] = Fluid2D([4172,4162,4188],1); -ELEMENTS[756] = Fluid2D([4162,4144,4134],1); -ELEMENTS[757] = Fluid2D([4188,4162,4183],1); -ELEMENTS[758] = Fluid2D([4134,4144,4116],1); -ELEMENTS[759] = Fluid2D([4134,4116,4108],1); -ELEMENTS[760] = Fluid2D([4134,4108,4135],1); -ELEMENTS[761] = Fluid2D([4108,4116,4089],1); -ELEMENTS[762] = Fluid2D([4108,4089,4079],1); -ELEMENTS[763] = Fluid2D([4079,4089,4062],1); -ELEMENTS[764] = Fluid2D([4108,4079,4101],1); -ELEMENTS[765] = Fluid2D([4062,4089,4071],1); -ELEMENTS[766] = Fluid2D([4071,4089,4097],1); -ELEMENTS[767] = Fluid2D([4062,4071,4045],1); -ELEMENTS[768] = Fluid2D([4062,4045,4037],1); -ELEMENTS[769] = Fluid2D([4062,4037,4055],1); -ELEMENTS[770] = Fluid2D([4037,4045,4016],1); -ELEMENTS[771] = Fluid2D([4055,4037,4030],1); -ELEMENTS[772] = Fluid2D([4062,4055,4079],1); -ELEMENTS[773] = Fluid2D([4079,4055,4074],1); -ELEMENTS[774] = Fluid2D([4074,4055,4047],1); -ELEMENTS[775] = Fluid2D([4079,4074,4101],1); -ELEMENTS[776] = Fluid2D([4101,4074,4099],1); -ELEMENTS[777] = Fluid2D([4101,4099,4127],1); -ELEMENTS[778] = Fluid2D([4127,4099,4112],1); -ELEMENTS[779] = Fluid2D([4074,4047,4052],1); -ELEMENTS[780] = Fluid2D([4047,4055,4030],1); -ELEMENTS[781] = Fluid2D([4047,4030,4022],1); -ELEMENTS[782] = Fluid2D([4022,4030,4001],1); -ELEMENTS[783] = Fluid2D([4047,4022,4052],1); -ELEMENTS[784] = Fluid2D([4172,4188,4198],1); -ELEMENTS[785] = Fluid2D([4176,4172,4198],1); -ELEMENTS[786] = Fluid2D([3930,3938,3909],1); -ELEMENTS[787] = Fluid2D([3936,3914,3908],1); -ELEMENTS[788] = Fluid2D([3908,3914,3887],1); -ELEMENTS[789] = Fluid2D([3925,3897,3920],1); -ELEMENTS[790] = Fluid2D([3925,3920,3944],1); -ELEMENTS[791] = Fluid2D([3920,3897,3882],1); -ELEMENTS[792] = Fluid2D([3928,3936,3908],1); -ELEMENTS[793] = Fluid2D([4030,4037,4010],1); -ELEMENTS[794] = Fluid2D([4010,4037,4016],1); -ELEMENTS[795] = Fluid2D([4010,4016,3988],1); -ELEMENTS[796] = Fluid2D([352,313,332],1); -ELEMENTS[797] = Fluid2D([332,313,294],1); -ELEMENTS[798] = Fluid2D([352,332,375],1); -ELEMENTS[799] = Fluid2D([352,375,396],1); -ELEMENTS[800] = Fluid2D([294,313,278],1); -ELEMENTS[801] = Fluid2D([278,313,292],1); -ELEMENTS[802] = Fluid2D([294,278,259],1); -ELEMENTS[803] = Fluid2D([292,313,331],1); -ELEMENTS[804] = Fluid2D([278,292,256],1); -ELEMENTS[805] = Fluid2D([294,259,277],1); -ELEMENTS[806] = Fluid2D([259,278,244],1); -ELEMENTS[807] = Fluid2D([259,244,230],1); -ELEMENTS[808] = Fluid2D([259,230,245],1); -ELEMENTS[809] = Fluid2D([230,244,216],1); -ELEMENTS[810] = Fluid2D([230,216,203],1); -ELEMENTS[811] = Fluid2D([230,203,218],1); -ELEMENTS[812] = Fluid2D([203,216,188],1); -ELEMENTS[813] = Fluid2D([203,188,182],1); -ELEMENTS[814] = Fluid2D([203,182,192],1); -ELEMENTS[815] = Fluid2D([182,188,170],1); -ELEMENTS[816] = Fluid2D([332,294,315],1); -ELEMENTS[817] = Fluid2D([245,230,218],1); -ELEMENTS[818] = Fluid2D([245,218,233],1); -ELEMENTS[819] = Fluid2D([188,216,201],1); -ELEMENTS[820] = Fluid2D([201,216,229],1); -ELEMENTS[821] = Fluid2D([218,203,192],1); -ELEMENTS[822] = Fluid2D([218,192,205],1); -ELEMENTS[823] = Fluid2D([259,245,277],1); -ELEMENTS[824] = Fluid2D([277,245,262],1); -ELEMENTS[825] = Fluid2D([277,262,298],1); -ELEMENTS[826] = Fluid2D([298,262,279],1); -ELEMENTS[827] = Fluid2D([279,262,246],1); -ELEMENTS[828] = Fluid2D([262,245,233],1); -ELEMENTS[829] = Fluid2D([262,233,246],1); -ELEMENTS[830] = Fluid2D([246,233,219],1); -ELEMENTS[831] = Fluid2D([246,219,234],1); -ELEMENTS[832] = Fluid2D([219,233,205],1); -ELEMENTS[833] = Fluid2D([219,205,196],1); -ELEMENTS[834] = Fluid2D([196,205,185],1); -ELEMENTS[835] = Fluid2D([219,196,208],1); -ELEMENTS[836] = Fluid2D([277,298,315],1); -ELEMENTS[837] = Fluid2D([279,246,266],1); -ELEMENTS[838] = Fluid2D([196,185,173],1); -ELEMENTS[839] = Fluid2D([219,208,234],1); -ELEMENTS[840] = Fluid2D([234,208,221],1); -ELEMENTS[841] = Fluid2D([221,208,197],1); -ELEMENTS[842] = Fluid2D([234,221,250],1); -ELEMENTS[843] = Fluid2D([185,205,192],1); -ELEMENTS[844] = Fluid2D([185,192,171],1); -ELEMENTS[845] = Fluid2D([208,196,186],1); -ELEMENTS[846] = Fluid2D([246,234,266],1); -ELEMENTS[847] = Fluid2D([266,234,250],1); -ELEMENTS[848] = Fluid2D([266,250,284],1); -ELEMENTS[849] = Fluid2D([284,250,269],1); -ELEMENTS[850] = Fluid2D([266,284,302],1); -ELEMENTS[851] = Fluid2D([302,284,323],1); -ELEMENTS[852] = Fluid2D([323,284,305],1); -ELEMENTS[853] = Fluid2D([302,323,341],1); -ELEMENTS[854] = Fluid2D([197,208,186],1); -ELEMENTS[855] = Fluid2D([197,186,175],1); -ELEMENTS[856] = Fluid2D([250,221,239],1); -ELEMENTS[857] = Fluid2D([269,250,239],1); -ELEMENTS[858] = Fluid2D([269,239,254],1); -ELEMENTS[859] = Fluid2D([254,239,224],1); -ELEMENTS[860] = Fluid2D([269,254,290],1); -ELEMENTS[861] = Fluid2D([315,298,336],1); -ELEMENTS[862] = Fluid2D([315,336,354],1); -ELEMENTS[863] = Fluid2D([315,354,332],1); -ELEMENTS[864] = Fluid2D([221,197,210],1); -ELEMENTS[865] = Fluid2D([284,269,305],1); -ELEMENTS[866] = Fluid2D([305,269,290],1); -ELEMENTS[867] = Fluid2D([305,290,328],1); -ELEMENTS[868] = Fluid2D([305,328,345],1); -ELEMENTS[869] = Fluid2D([328,290,314],1); -ELEMENTS[870] = Fluid2D([305,345,323],1); -ELEMENTS[871] = Fluid2D([323,345,362],1); -ELEMENTS[872] = Fluid2D([362,345,386],1); -ELEMENTS[873] = Fluid2D([323,362,341],1); -ELEMENTS[874] = Fluid2D([341,362,383],1); -ELEMENTS[875] = Fluid2D([383,362,406],1); -ELEMENTS[876] = Fluid2D([341,383,357],1); -ELEMENTS[877] = Fluid2D([362,386,406],1); -ELEMENTS[878] = Fluid2D([406,386,435],1); -ELEMENTS[879] = Fluid2D([345,328,367],1); -ELEMENTS[880] = Fluid2D([328,314,353],1); -ELEMENTS[881] = Fluid2D([386,345,367],1); -ELEMENTS[882] = Fluid2D([386,367,412],1); -ELEMENTS[883] = Fluid2D([314,290,275],1); -ELEMENTS[884] = Fluid2D([192,182,171],1); -ELEMENTS[885] = Fluid2D([315,294,277],1); -ELEMENTS[886] = Fluid2D([353,314,338],1); -ELEMENTS[887] = Fluid2D([254,224,243],1); -ELEMENTS[888] = Fluid2D([254,243,275],1); -ELEMENTS[889] = Fluid2D([254,275,290],1); -ELEMENTS[890] = Fluid2D([275,243,264],1); -ELEMENTS[891] = Fluid2D([243,224,213],1); -ELEMENTS[892] = Fluid2D([275,264,300],1); -ELEMENTS[893] = Fluid2D([264,243,232],1); -ELEMENTS[894] = Fluid2D([186,196,173],1); -ELEMENTS[895] = Fluid2D([210,197,189],1); -ELEMENTS[896] = Fluid2D([189,197,175],1); -ELEMENTS[897] = Fluid2D([189,175,176],1); -ELEMENTS[898] = Fluid2D([189,176,191],1); -ELEMENTS[899] = Fluid2D([191,176,177],1); -ELEMENTS[900] = Fluid2D([191,177,194],1); -ELEMENTS[901] = Fluid2D([189,191,210],1); -ELEMENTS[902] = Fluid2D([194,177,178],1); -ELEMENTS[903] = Fluid2D([191,194,213],1); -ELEMENTS[904] = Fluid2D([213,194,211],1); -ELEMENTS[905] = Fluid2D([213,211,232],1); -ELEMENTS[906] = Fluid2D([232,211,226],1); -ELEMENTS[907] = Fluid2D([232,226,252],1); -ELEMENTS[908] = Fluid2D([226,211,198],1); -ELEMENTS[909] = Fluid2D([226,198,214],1); -ELEMENTS[910] = Fluid2D([252,226,248],1); -ELEMENTS[911] = Fluid2D([232,252,264],1); -ELEMENTS[912] = Fluid2D([264,252,286],1); -ELEMENTS[913] = Fluid2D([264,286,300],1); -ELEMENTS[914] = Fluid2D([300,286,324],1); -ELEMENTS[915] = Fluid2D([286,252,276],1); -ELEMENTS[916] = Fluid2D([300,324,338],1); -ELEMENTS[917] = Fluid2D([338,324,363],1); -ELEMENTS[918] = Fluid2D([324,286,309],1); -ELEMENTS[919] = Fluid2D([363,324,342],1); -ELEMENTS[920] = Fluid2D([338,363,380],1); -ELEMENTS[921] = Fluid2D([300,338,314],1); -ELEMENTS[922] = Fluid2D([300,314,275],1); -ELEMENTS[923] = Fluid2D([198,211,178],1); -ELEMENTS[924] = Fluid2D([276,252,248],1); -ELEMENTS[925] = Fluid2D([276,248,270],1); -ELEMENTS[926] = Fluid2D([276,270,304],1); -ELEMENTS[927] = Fluid2D([270,248,238],1); -ELEMENTS[928] = Fluid2D([309,286,276],1); -ELEMENTS[929] = Fluid2D([309,276,304],1); -ELEMENTS[930] = Fluid2D([309,304,342],1); -ELEMENTS[931] = Fluid2D([309,342,324],1); -ELEMENTS[932] = Fluid2D([380,363,407],1); -ELEMENTS[933] = Fluid2D([304,270,296],1); -ELEMENTS[934] = Fluid2D([270,238,258],1); -ELEMENTS[935] = Fluid2D([238,248,214],1); -ELEMENTS[936] = Fluid2D([238,214,209],1); -ELEMENTS[937] = Fluid2D([363,342,390],1); -ELEMENTS[938] = Fluid2D([338,380,353],1); -ELEMENTS[939] = Fluid2D([353,380,395],1); -ELEMENTS[940] = Fluid2D([395,380,426],1); -ELEMENTS[941] = Fluid2D([353,395,367],1); -ELEMENTS[942] = Fluid2D([238,209,235],1); -ELEMENTS[943] = Fluid2D([214,198,184],1); -ELEMENTS[944] = Fluid2D([248,226,214],1); -ELEMENTS[945] = Fluid2D([209,214,184],1); -ELEMENTS[946] = Fluid2D([296,270,258],1); -ELEMENTS[947] = Fluid2D([407,363,390],1); -ELEMENTS[948] = Fluid2D([194,178,211],1); -ELEMENTS[949] = Fluid2D([304,296,343],1); -ELEMENTS[950] = Fluid2D([343,296,325],1); -ELEMENTS[951] = Fluid2D([304,343,342],1); -ELEMENTS[952] = Fluid2D([380,407,426],1); -ELEMENTS[953] = Fluid2D([426,407,451],1); -ELEMENTS[954] = Fluid2D([451,407,428],1); -ELEMENTS[955] = Fluid2D([426,451,471],1); -ELEMENTS[956] = Fluid2D([428,407,390],1); -ELEMENTS[957] = Fluid2D([428,390,411],1); -ELEMENTS[958] = Fluid2D([428,411,458],1); -ELEMENTS[959] = Fluid2D([411,390,369],1); -ELEMENTS[960] = Fluid2D([369,390,342],1); -ELEMENTS[961] = Fluid2D([369,342,343],1); -ELEMENTS[962] = Fluid2D([428,458,483],1); -ELEMENTS[963] = Fluid2D([483,458,503],1); -ELEMENTS[964] = Fluid2D([503,458,481],1); -ELEMENTS[965] = Fluid2D([483,503,530],1); -ELEMENTS[966] = Fluid2D([458,441,481],1); -ELEMENTS[967] = Fluid2D([411,369,394],1); -ELEMENTS[968] = Fluid2D([451,428,483],1); -ELEMENTS[969] = Fluid2D([503,481,535],1); -ELEMENTS[970] = Fluid2D([394,369,343],1); -ELEMENTS[971] = Fluid2D([411,394,441],1); -ELEMENTS[972] = Fluid2D([503,535,552],1); -ELEMENTS[973] = Fluid2D([411,441,458],1); -ELEMENTS[974] = Fluid2D([481,441,467],1); -ELEMENTS[975] = Fluid2D([481,514,535],1); -ELEMENTS[976] = Fluid2D([467,441,422],1); -ELEMENTS[977] = Fluid2D([467,422,448],1); -ELEMENTS[978] = Fluid2D([422,441,394],1); -ELEMENTS[979] = Fluid2D([422,394,378],1); -ELEMENTS[980] = Fluid2D([378,394,343],1); -ELEMENTS[981] = Fluid2D([422,378,403],1); -ELEMENTS[982] = Fluid2D([448,422,403],1); -ELEMENTS[983] = Fluid2D([448,403,431],1); -ELEMENTS[984] = Fluid2D([431,403,385],1); -ELEMENTS[985] = Fluid2D([448,431,480],1); -ELEMENTS[986] = Fluid2D([403,378,359],1); -ELEMENTS[987] = Fluid2D([431,385,413],1); -ELEMENTS[988] = Fluid2D([385,403,359],1); -ELEMENTS[989] = Fluid2D([385,359,344],1); -ELEMENTS[990] = Fluid2D([344,359,319],1); -ELEMENTS[991] = Fluid2D([359,378,325],1); -ELEMENTS[992] = Fluid2D([319,359,325],1); -ELEMENTS[993] = Fluid2D([319,325,287],1); -ELEMENTS[994] = Fluid2D([287,325,296],1); -ELEMENTS[995] = Fluid2D([319,287,285],1); -ELEMENTS[996] = Fluid2D([287,296,258],1); -ELEMENTS[997] = Fluid2D([319,285,316],1); -ELEMENTS[998] = Fluid2D([285,287,255],1); -ELEMENTS[999] = Fluid2D([319,316,344],1); -ELEMENTS[1000] = Fluid2D([344,316,340],1); -ELEMENTS[1001] = Fluid2D([344,340,368],1); -ELEMENTS[1002] = Fluid2D([340,316,303],1); -ELEMENTS[1003] = Fluid2D([368,340,370],1); -ELEMENTS[1004] = Fluid2D([340,303,326],1); -ELEMENTS[1005] = Fluid2D([344,368,385],1); -ELEMENTS[1006] = Fluid2D([385,368,413],1); -ELEMENTS[1007] = Fluid2D([413,368,370],1); -ELEMENTS[1008] = Fluid2D([303,316,282],1); -ELEMENTS[1009] = Fluid2D([340,326,370],1); -ELEMENTS[1010] = Fluid2D([326,303,289],1); -ELEMENTS[1011] = Fluid2D([289,303,268],1); -ELEMENTS[1012] = Fluid2D([326,289,310],1); -ELEMENTS[1013] = Fluid2D([552,535,593],1); -ELEMENTS[1014] = Fluid2D([467,448,495],1); -ELEMENTS[1015] = Fluid2D([467,495,514],1); -ELEMENTS[1016] = Fluid2D([495,448,480],1); -ELEMENTS[1017] = Fluid2D([495,480,525],1); -ELEMENTS[1018] = Fluid2D([525,480,504],1); -ELEMENTS[1019] = Fluid2D([495,525,543],1); -ELEMENTS[1020] = Fluid2D([543,525,589],1); -ELEMENTS[1021] = Fluid2D([495,543,514],1); -ELEMENTS[1022] = Fluid2D([514,571,535],1); -ELEMENTS[1023] = Fluid2D([525,504,567],1); -ELEMENTS[1024] = Fluid2D([504,480,459],1); -ELEMENTS[1025] = Fluid2D([238,235,258],1); -ELEMENTS[1026] = Fluid2D([258,235,255],1); -ELEMENTS[1027] = Fluid2D([480,431,459],1); -ELEMENTS[1028] = Fluid2D([459,431,413],1); -ELEMENTS[1029] = Fluid2D([503,552,530],1); -ELEMENTS[1030] = Fluid2D([218,205,233],1); -ELEMENTS[1031] = Fluid2D([4056,4043,4025],1); -ELEMENTS[1032] = Fluid2D([239,221,210],1); -ELEMENTS[1033] = Fluid2D([3929,3951,3962],1); -ELEMENTS[1034] = Fluid2D([3962,3951,3980],1); -ELEMENTS[1035] = Fluid2D([4054,4080,4066],1); -ELEMENTS[1036] = Fluid2D([4054,4066,4040],1); -ELEMENTS[1037] = Fluid2D([4040,4066,4050],1); -ELEMENTS[1038] = Fluid2D([4040,4050,4021],1); -ELEMENTS[1039] = Fluid2D([4054,4040,4028],1); -ELEMENTS[1040] = Fluid2D([4040,4021,4007],1); -ELEMENTS[1041] = Fluid2D([4021,4050,4036],1); -ELEMENTS[1042] = Fluid2D([4054,4028,4034],1); -ELEMENTS[1043] = Fluid2D([4028,4040,4007],1); -ELEMENTS[1044] = Fluid2D([4028,4007,4009],1); -ELEMENTS[1045] = Fluid2D([4007,4021,3997],1); -ELEMENTS[1046] = Fluid2D([3997,4021,4005],1); -ELEMENTS[1047] = Fluid2D([4007,3997,3984],1); -ELEMENTS[1048] = Fluid2D([4005,4021,4036],1); -ELEMENTS[1049] = Fluid2D([3984,3997,3967],1); -ELEMENTS[1050] = Fluid2D([4007,3984,3985],1); -ELEMENTS[1051] = Fluid2D([3985,3984,3958],1); -ELEMENTS[1052] = Fluid2D([3997,4005,3977],1); -ELEMENTS[1053] = Fluid2D([279,266,302],1); -ELEMENTS[1054] = Fluid2D([861,838,904],1); -ELEMENTS[1055] = Fluid2D([904,838,877],1); -ELEMENTS[1056] = Fluid2D([904,877,945],1); -ELEMENTS[1057] = Fluid2D([877,838,808],1); -ELEMENTS[1058] = Fluid2D([808,838,772],1); -ELEMENTS[1059] = Fluid2D([808,772,747],1); -ELEMENTS[1060] = Fluid2D([808,747,785],1); -ELEMENTS[1061] = Fluid2D([785,747,723],1); -ELEMENTS[1062] = Fluid2D([808,785,848],1); -ELEMENTS[1063] = Fluid2D([808,848,877],1); -ELEMENTS[1064] = Fluid2D([877,848,916],1); -ELEMENTS[1065] = Fluid2D([916,848,889],1); -ELEMENTS[1066] = Fluid2D([877,916,945],1); -ELEMENTS[1067] = Fluid2D([945,916,1000],1); -ELEMENTS[1068] = Fluid2D([945,1000,1016],1); -ELEMENTS[1069] = Fluid2D([1000,916,956],1); -ELEMENTS[1070] = Fluid2D([889,848,823],1); -ELEMENTS[1071] = Fluid2D([916,889,956],1); -ELEMENTS[1072] = Fluid2D([956,889,928],1); -ELEMENTS[1073] = Fluid2D([928,889,859],1); -ELEMENTS[1074] = Fluid2D([956,928,996],1); -ELEMENTS[1075] = Fluid2D([1016,1000,1079],1); -ELEMENTS[1076] = Fluid2D([859,889,823],1); -ELEMENTS[1077] = Fluid2D([859,823,795],1); -ELEMENTS[1078] = Fluid2D([996,928,969],1); -ELEMENTS[1079] = Fluid2D([747,772,712],1); -ELEMENTS[1080] = Fluid2D([712,772,735],1); -ELEMENTS[1081] = Fluid2D([859,795,832],1); -ELEMENTS[1082] = Fluid2D([795,823,758],1); -ELEMENTS[1083] = Fluid2D([785,723,758],1); -ELEMENTS[1084] = Fluid2D([758,723,696],1); -ELEMENTS[1085] = Fluid2D([785,758,823],1); -ELEMENTS[1086] = Fluid2D([785,823,848],1); -ELEMENTS[1087] = Fluid2D([758,696,734],1); -ELEMENTS[1088] = Fluid2D([696,723,664],1); -ELEMENTS[1089] = Fluid2D([696,664,640],1); -ELEMENTS[1090] = Fluid2D([664,723,685],1); -ELEMENTS[1091] = Fluid2D([640,664,603],1); -ELEMENTS[1092] = Fluid2D([696,640,675],1); -ELEMENTS[1093] = Fluid2D([734,696,675],1); -ELEMENTS[1094] = Fluid2D([758,734,795],1); -ELEMENTS[1095] = Fluid2D([795,734,774],1); -ELEMENTS[1096] = Fluid2D([774,734,711],1); -ELEMENTS[1097] = Fluid2D([795,774,832],1); -ELEMENTS[1098] = Fluid2D([832,774,810],1); -ELEMENTS[1099] = Fluid2D([832,810,878],1); -ELEMENTS[1100] = Fluid2D([810,774,746],1); -ELEMENTS[1101] = Fluid2D([711,734,675],1); -ELEMENTS[1102] = Fluid2D([711,675,652],1); -ELEMENTS[1103] = Fluid2D([652,675,619],1); -ELEMENTS[1104] = Fluid2D([619,675,640],1); -ELEMENTS[1105] = Fluid2D([619,640,584],1); -ELEMENTS[1106] = Fluid2D([584,640,603],1); -ELEMENTS[1107] = Fluid2D([711,652,690],1); -ELEMENTS[1108] = Fluid2D([746,774,711],1); -ELEMENTS[1109] = Fluid2D([746,711,690],1); -ELEMENTS[1110] = Fluid2D([746,690,729],1); -ELEMENTS[1111] = Fluid2D([729,690,669],1); -ELEMENTS[1112] = Fluid2D([746,729,791],1); -ELEMENTS[1113] = Fluid2D([746,791,810],1); -ELEMENTS[1114] = Fluid2D([810,791,854],1); -ELEMENTS[1115] = Fluid2D([854,791,829],1); -ELEMENTS[1116] = Fluid2D([810,854,878],1); -ELEMENTS[1117] = Fluid2D([878,854,921],1); -ELEMENTS[1118] = Fluid2D([921,854,894],1); -ELEMENTS[1119] = Fluid2D([878,921,946],1); -ELEMENTS[1120] = Fluid2D([854,829,894],1); -ELEMENTS[1121] = Fluid2D([669,690,633],1); -ELEMENTS[1122] = Fluid2D([894,829,873],1); -ELEMENTS[1123] = Fluid2D([946,921,990],1); -ELEMENTS[1124] = Fluid2D([729,669,708],1); -ELEMENTS[1125] = Fluid2D([829,791,767],1); -ELEMENTS[1126] = Fluid2D([832,878,898],1); -ELEMENTS[1127] = Fluid2D([878,946,898],1); -ELEMENTS[1128] = Fluid2D([898,946,969],1); -ELEMENTS[1129] = Fluid2D([969,946,1015],1); -ELEMENTS[1130] = Fluid2D([969,1015,1034],1); -ELEMENTS[1131] = Fluid2D([1015,946,990],1); -ELEMENTS[1132] = Fluid2D([1015,990,1058],1); -ELEMENTS[1133] = Fluid2D([1058,990,1044],1); -ELEMENTS[1134] = Fluid2D([1015,1058,1105],1); -ELEMENTS[1135] = Fluid2D([1058,1044,1115],1); -ELEMENTS[1136] = Fluid2D([1044,990,960],1); -ELEMENTS[1137] = Fluid2D([1034,1015,1105],1); -ELEMENTS[1138] = Fluid2D([969,1034,996],1); -ELEMENTS[1139] = Fluid2D([996,1034,1095],1); -ELEMENTS[1140] = Fluid2D([791,729,767],1); -ELEMENTS[1141] = Fluid2D([767,729,708],1); -ELEMENTS[1142] = Fluid2D([767,708,749],1); -ELEMENTS[1143] = Fluid2D([767,749,813],1); -ELEMENTS[1144] = Fluid2D([749,708,687],1); -ELEMENTS[1145] = Fluid2D([921,894,960],1); -ELEMENTS[1146] = Fluid2D([921,960,990],1); -ELEMENTS[1147] = Fluid2D([960,894,943],1); -ELEMENTS[1148] = Fluid2D([943,894,873],1); -ELEMENTS[1149] = Fluid2D([960,943,1012],1); -ELEMENTS[1150] = Fluid2D([960,1012,1044],1); -ELEMENTS[1151] = Fluid2D([1044,1012,1075],1); -ELEMENTS[1152] = Fluid2D([1075,1012,1064],1); -ELEMENTS[1153] = Fluid2D([1044,1075,1126],1); -ELEMENTS[1154] = Fluid2D([1126,1075,1132],1); -ELEMENTS[1155] = Fluid2D([1064,1012,982],1); -ELEMENTS[1156] = Fluid2D([1075,1064,1132],1); -ELEMENTS[1157] = Fluid2D([1012,943,982],1); -ELEMENTS[1158] = Fluid2D([982,943,915],1); -ELEMENTS[1159] = Fluid2D([915,943,873],1); -ELEMENTS[1160] = Fluid2D([915,873,851],1); -ELEMENTS[1161] = Fluid2D([982,915,963],1); -ELEMENTS[1162] = Fluid2D([851,873,813],1); -ELEMENTS[1163] = Fluid2D([813,873,829],1); -ELEMENTS[1164] = Fluid2D([813,829,767],1); -ELEMENTS[1165] = Fluid2D([915,851,899],1); -ELEMENTS[1166] = Fluid2D([963,915,899],1); -ELEMENTS[1167] = Fluid2D([963,899,951],1); -ELEMENTS[1168] = Fluid2D([951,899,883],1); -ELEMENTS[1169] = Fluid2D([963,951,1019],1); -ELEMENTS[1170] = Fluid2D([982,963,1039],1); -ELEMENTS[1171] = Fluid2D([899,851,835],1); -ELEMENTS[1172] = Fluid2D([951,883,929],1); -ELEMENTS[1173] = Fluid2D([1064,982,1039],1); -ELEMENTS[1174] = Fluid2D([1064,1039,1143],1); -ELEMENTS[1175] = Fluid2D([690,652,633],1); -ELEMENTS[1176] = Fluid2D([633,652,599],1); -ELEMENTS[1177] = Fluid2D([633,599,579],1); -ELEMENTS[1178] = Fluid2D([579,599,546],1); -ELEMENTS[1179] = Fluid2D([599,652,619],1); -ELEMENTS[1180] = Fluid2D([929,883,863],1); -ELEMENTS[1181] = Fluid2D([883,899,835],1); -ELEMENTS[1182] = Fluid2D([883,835,819],1); -ELEMENTS[1183] = Fluid2D([883,819,863],1); -ELEMENTS[1184] = Fluid2D([863,819,803],1); -ELEMENTS[1185] = Fluid2D([819,835,773],1); -ELEMENTS[1186] = Fluid2D([863,803,852],1); -ELEMENTS[1187] = Fluid2D([803,819,757],1); -ELEMENTS[1188] = Fluid2D([819,773,757],1); -ELEMENTS[1189] = Fluid2D([757,773,713],1); -ELEMENTS[1190] = Fluid2D([773,835,790],1); -ELEMENTS[1191] = Fluid2D([713,773,727],1); -ELEMENTS[1192] = Fluid2D([757,713,697],1); -ELEMENTS[1193] = Fluid2D([852,803,789],1); -ELEMENTS[1194] = Fluid2D([790,835,851],1); -ELEMENTS[1195] = Fluid2D([790,851,813],1); -ELEMENTS[1196] = Fluid2D([727,773,790],1); -ELEMENTS[1197] = Fluid2D([727,790,749],1); -ELEMENTS[1198] = Fluid2D([697,713,654],1); -ELEMENTS[1199] = Fluid2D([789,803,742],1); -ELEMENTS[1200] = Fluid2D([945,1016,974],1); -ELEMENTS[1201] = Fluid2D([974,1016,1070],1); -ELEMENTS[1202] = Fluid2D([1039,963,1019],1); -ELEMENTS[1203] = Fluid2D([1039,1019,1093],1); -ELEMENTS[1204] = Fluid2D([1039,1093,1143],1); -ELEMENTS[1205] = Fluid2D([1093,1019,1088],1); -ELEMENTS[1206] = Fluid2D([1093,1088,1152],1); -ELEMENTS[1207] = Fluid2D([1088,1019,997],1); -ELEMENTS[1208] = Fluid2D([1088,997,1052],1); -ELEMENTS[1209] = Fluid2D([997,1019,951],1); -ELEMENTS[1210] = Fluid2D([997,951,929],1); -ELEMENTS[1211] = Fluid2D([669,633,611],1); -ELEMENTS[1212] = Fluid2D([669,611,650],1); -ELEMENTS[1213] = Fluid2D([611,633,579],1); -ELEMENTS[1214] = Fluid2D([723,747,685],1); -ELEMENTS[1215] = Fluid2D([1000,956,1026],1); -ELEMENTS[1216] = Fluid2D([1026,956,996],1); -ELEMENTS[1217] = Fluid2D([1026,996,1095],1); -ELEMENTS[1218] = Fluid2D([1000,1086,1079],1); -ELEMENTS[1219] = Fluid2D([904,945,974],1); -ELEMENTS[1220] = Fluid2D([928,859,898],1); -ELEMENTS[1221] = Fluid2D([898,859,832],1); -ELEMENTS[1222] = Fluid2D([928,898,969],1); -ELEMENTS[1223] = Fluid2D([772,838,798],1); -ELEMENTS[1224] = Fluid2D([708,669,650],1); -ELEMENTS[1225] = Fluid2D([813,749,790],1); -ELEMENTS[1226] = Fluid2D([4252,4260,4238],1); -ELEMENTS[1227] = Fluid2D([4238,4260,4251],1); -ELEMENTS[1228] = Fluid2D([4251,4260,4265],1); -ELEMENTS[1229] = Fluid2D([4251,4265,4258],1); -ELEMENTS[1230] = Fluid2D([4238,4251,4229],1); -ELEMENTS[1231] = Fluid2D([687,708,650],1); -ELEMENTS[1232] = Fluid2D([974,931,904],1); -ELEMENTS[1233] = Fluid2D([3883,3854,3876],1); -ELEMENTS[1234] = Fluid2D([3876,3854,3848],1); -ELEMENTS[1235] = Fluid2D([3876,3848,3863],1); -ELEMENTS[1236] = Fluid2D([3848,3854,3829],1); -ELEMENTS[1237] = Fluid2D([3863,3848,3835],1); -ELEMENTS[1238] = Fluid2D([3876,3863,3897],1); -ELEMENTS[1239] = Fluid2D([3848,3829,3818],1); -ELEMENTS[1240] = Fluid2D([3818,3829,3802],1); -ELEMENTS[1241] = Fluid2D([3863,3835,3855],1); -ELEMENTS[1242] = Fluid2D([3848,3818,3835],1); -ELEMENTS[1243] = Fluid2D([3829,3854,3834],1); -ELEMENTS[1244] = Fluid2D([3834,3854,3860],1); -ELEMENTS[1245] = Fluid2D([3834,3860,3849],1); -ELEMENTS[1246] = Fluid2D([3849,3860,3877],1); -ELEMENTS[1247] = Fluid2D([3834,3849,3820],1); -ELEMENTS[1248] = Fluid2D([3820,3849,3830],1); -ELEMENTS[1249] = Fluid2D([3820,3830,3804],1); -ELEMENTS[1250] = Fluid2D([3834,3820,3808],1); -ELEMENTS[1251] = Fluid2D([3820,3804,3785],1); -ELEMENTS[1252] = Fluid2D([3834,3808,3829],1); -ELEMENTS[1253] = Fluid2D([3829,3808,3802],1); -ELEMENTS[1254] = Fluid2D([3802,3808,3780],1); -ELEMENTS[1255] = Fluid2D([3780,3808,3785],1); -ELEMENTS[1256] = Fluid2D([3780,3785,3756],1); -ELEMENTS[1257] = Fluid2D([3756,3785,3773],1); -ELEMENTS[1258] = Fluid2D([3780,3756,3749],1); -ELEMENTS[1259] = Fluid2D([3802,3780,3768],1); -ELEMENTS[1260] = Fluid2D([3773,3785,3804],1); -ELEMENTS[1261] = Fluid2D([3773,3804,3781],1); -ELEMENTS[1262] = Fluid2D([3773,3781,3752],1); -ELEMENTS[1263] = Fluid2D([3781,3804,3809],1); -ELEMENTS[1264] = Fluid2D([3749,3756,3728],1); -ELEMENTS[1265] = Fluid2D([3780,3749,3768],1); -ELEMENTS[1266] = Fluid2D([3768,3749,3726],1); -ELEMENTS[1267] = Fluid2D([3804,3830,3809],1); -ELEMENTS[1268] = Fluid2D([3809,3830,3836],1); -ELEMENTS[1269] = Fluid2D([3808,3820,3785],1); -ELEMENTS[1270] = Fluid2D([3756,3773,3742],1); -ELEMENTS[1271] = Fluid2D([986,970,1051],1); -ELEMENTS[1272] = Fluid2D([858,895,926],1); -ELEMENTS[1273] = Fluid2D([712,676,651],1); -ELEMENTS[1274] = Fluid2D([4069,4052,4043],1); -ELEMENTS[1275] = Fluid2D([4140,4159,4168],1); -ELEMENTS[1276] = Fluid2D([4258,4245,4251],1); -ELEMENTS[1277] = Fluid2D([4251,4245,4229],1); -ELEMENTS[1278] = Fluid2D([4229,4232,4218],1); -ELEMENTS[1279] = Fluid2D([4114,4100,4126],1); -ELEMENTS[1280] = Fluid2D([4126,4100,4119],1); -ELEMENTS[1281] = Fluid2D([4148,4176,4159],1); -ELEMENTS[1282] = Fluid2D([4159,4176,4189],1); -ELEMENTS[1283] = Fluid2D([4159,4189,4168],1); -ELEMENTS[1284] = Fluid2D([4189,4176,4205],1); -ELEMENTS[1285] = Fluid2D([4205,4176,4198],1); -ELEMENTS[1286] = Fluid2D([4205,4198,4219],1); -ELEMENTS[1287] = Fluid2D([4219,4198,4212],1); -ELEMENTS[1288] = Fluid2D([4205,4219,4225],1); -ELEMENTS[1289] = Fluid2D([4219,4212,4233],1); -ELEMENTS[1290] = Fluid2D([4205,4225,4222],1); -ELEMENTS[1291] = Fluid2D([4222,4225,4240],1); -ELEMENTS[1292] = Fluid2D([4240,4225,4241],1); -ELEMENTS[1293] = Fluid2D([4240,4241,4255],1); -ELEMENTS[1294] = Fluid2D([4255,4241,4253],1); -ELEMENTS[1295] = Fluid2D([4241,4225,4219],1); -ELEMENTS[1296] = Fluid2D([4253,4241,4233],1); -ELEMENTS[1297] = Fluid2D([4255,4253,4268],1); -ELEMENTS[1298] = Fluid2D([4268,4253,4266],1); -ELEMENTS[1299] = Fluid2D([4189,4205,4222],1); -ELEMENTS[1300] = Fluid2D([4212,4198,4188],1); -ELEMENTS[1301] = Fluid2D([4050,4077,4064],1); -ELEMENTS[1302] = Fluid2D([4182,4195,4170],1); -ELEMENTS[1303] = Fluid2D([4170,4195,4183],1); -ELEMENTS[1304] = Fluid2D([4170,4183,4155],1); -ELEMENTS[1305] = Fluid2D([4183,4195,4202],1); -ELEMENTS[1306] = Fluid2D([4170,4155,4135],1); -ELEMENTS[1307] = Fluid2D([4135,4155,4134],1); -ELEMENTS[1308] = Fluid2D([4134,4155,4162],1); -ELEMENTS[1309] = Fluid2D([4162,4155,4183],1); -ELEMENTS[1310] = Fluid2D([4202,4195,4218],1); -ELEMENTS[1311] = Fluid2D([4183,4202,4188],1); -ELEMENTS[1312] = Fluid2D([609,559,585],1); -ELEMENTS[1313] = Fluid2D([609,585,642],1); -ELEMENTS[1314] = Fluid2D([757,697,742],1); -ELEMENTS[1315] = Fluid2D([4127,4135,4101],1); -ELEMENTS[1316] = Fluid2D([442,395,426],1); -ELEMENTS[1317] = Fluid2D([367,328,353],1); -ELEMENTS[1318] = Fluid2D([3868,3895,3878],1); -ELEMENTS[1319] = Fluid2D([3878,3895,3902],1); -ELEMENTS[1320] = Fluid2D([3878,3902,3880],1); -ELEMENTS[1321] = Fluid2D([3878,3880,3853],1); -ELEMENTS[1322] = Fluid2D([3853,3880,3858],1); -ELEMENTS[1323] = Fluid2D([3878,3853,3850],1); -ELEMENTS[1324] = Fluid2D([3853,3858,3827],1); -ELEMENTS[1325] = Fluid2D([3878,3850,3868],1); -ELEMENTS[1326] = Fluid2D([3868,3850,3836],1); -ELEMENTS[1327] = Fluid2D([3827,3858,3842],1); -ELEMENTS[1328] = Fluid2D([3858,3880,3887],1); -ELEMENTS[1329] = Fluid2D([3850,3853,3828],1); -ELEMENTS[1330] = Fluid2D([3828,3853,3827],1); -ELEMENTS[1331] = Fluid2D([3850,3828,3823],1); -ELEMENTS[1332] = Fluid2D([4096,4082,4068],1); -ELEMENTS[1333] = Fluid2D([4104,4119,4090],1); -ELEMENTS[1334] = Fluid2D([285,255,249],1); -ELEMENTS[1335] = Fluid2D([285,249,282],1); -ELEMENTS[1336] = Fluid2D([249,255,222],1); -ELEMENTS[1337] = Fluid2D([4064,4036,4050],1); -ELEMENTS[1338] = Fluid2D([4084,4099,4074],1); -ELEMENTS[1339] = Fluid2D([4131,4148,4159],1); -ELEMENTS[1340] = Fluid2D([884,920,970],1); -ELEMENTS[1341] = Fluid2D([884,970,917],1); -ELEMENTS[1342] = Fluid2D([4271,4285,4277],1); -ELEMENTS[1343] = Fluid2D([4277,4285,4286],1); -ELEMENTS[1344] = Fluid2D([4277,4286,4276],1); -ELEMENTS[1345] = Fluid2D([412,435,386],1); -ELEMENTS[1346] = Fluid2D([3903,3876,3897],1); -ELEMENTS[1347] = Fluid2D([4154,4170,4135],1); -ELEMENTS[1348] = Fluid2D([4011,4000,4027],1); -ELEMENTS[1349] = Fluid2D([4245,4249,4232],1); -ELEMENTS[1350] = Fluid2D([4245,4232,4229],1); -ELEMENTS[1351] = Fluid2D([4218,4223,4202],1); -ELEMENTS[1352] = Fluid2D([4232,4249,4243],1); -ELEMENTS[1353] = Fluid2D([4249,4259,4243],1); -ELEMENTS[1354] = Fluid2D([4068,4042,4057],1); -ELEMENTS[1355] = Fluid2D([4001,3993,4022],1); -ELEMENTS[1356] = Fluid2D([3959,3987,3966],1); -ELEMENTS[1357] = Fluid2D([4181,4153,4160],1); -ELEMENTS[1358] = Fluid2D([383,427,401],1); -ELEMENTS[1359] = Fluid2D([4195,4208,4218],1); -ELEMENTS[1360] = Fluid2D([515,546,568],1); -ELEMENTS[1361] = Fluid2D([568,546,599],1); -ELEMENTS[1362] = Fluid2D([666,609,642],1); -ELEMENTS[1363] = Fluid2D([4108,4101,4135],1); -ELEMENTS[1364] = Fluid2D([395,412,367],1); -ELEMENTS[1365] = Fluid2D([4136,4113,4110],1); -ELEMENTS[1366] = Fluid2D([4110,4113,4083],1); -ELEMENTS[1367] = Fluid2D([401,357,383],1); -ELEMENTS[1368] = Fluid2D([713,727,670],1); -ELEMENTS[1369] = Fluid2D([4070,4054,4034],1); -ELEMENTS[1370] = Fluid2D([4038,4060,4061],1); -ELEMENTS[1371] = Fluid2D([1001,974,1070],1); -ELEMENTS[1372] = Fluid2D([4250,4266,4253],1); -ELEMENTS[1373] = Fluid2D([749,687,727],1); -ELEMENTS[1374] = Fluid2D([255,287,258],1); -ELEMENTS[1375] = Fluid2D([863,852,918],1); -ELEMENTS[1376] = Fluid2D([863,918,929],1); -ELEMENTS[1377] = Fluid2D([929,918,984],1); -ELEMENTS[1378] = Fluid2D([984,918,968],1); -ELEMENTS[1379] = Fluid2D([929,984,997],1); -ELEMENTS[1380] = Fluid2D([968,918,900],1); -ELEMENTS[1381] = Fluid2D([984,968,1031],1); -ELEMENTS[1382] = Fluid2D([918,852,900],1); -ELEMENTS[1383] = Fluid2D([900,852,837],1); -ELEMENTS[1384] = Fluid2D([837,852,789],1); -ELEMENTS[1385] = Fluid2D([837,789,776],1); -ELEMENTS[1386] = Fluid2D([900,837,886],1); -ELEMENTS[1387] = Fluid2D([776,789,728],1); -ELEMENTS[1388] = Fluid2D([837,776,825],1); -ELEMENTS[1389] = Fluid2D([900,886,953],1); -ELEMENTS[1390] = Fluid2D([825,776,763],1); -ELEMENTS[1391] = Fluid2D([776,728,716],1); -ELEMENTS[1392] = Fluid2D([886,837,825],1); -ELEMENTS[1393] = Fluid2D([886,825,876],1); -ELEMENTS[1394] = Fluid2D([886,876,940],1); -ELEMENTS[1395] = Fluid2D([876,825,811],1); -ELEMENTS[1396] = Fluid2D([728,789,742],1); -ELEMENTS[1397] = Fluid2D([728,742,684],1); -ELEMENTS[1398] = Fluid2D([684,742,697],1); -ELEMENTS[1399] = Fluid2D([728,684,673],1); -ELEMENTS[1400] = Fluid2D([673,684,625],1); -ELEMENTS[1401] = Fluid2D([728,673,716],1); -ELEMENTS[1402] = Fluid2D([716,673,658],1); -ELEMENTS[1403] = Fluid2D([716,658,705],1); -ELEMENTS[1404] = Fluid2D([658,673,618],1); -ELEMENTS[1405] = Fluid2D([3886,3868,3859],1); -ELEMENTS[1406] = Fluid2D([4259,4250,4243],1); -ELEMENTS[1407] = Fluid2D([4243,4250,4233],1); -ELEMENTS[1408] = Fluid2D([3933,3940,3915],1); -ELEMENTS[1409] = Fluid2D([3915,3940,3921],1); -ELEMENTS[1410] = Fluid2D([235,209,206],1); -ELEMENTS[1411] = Fluid2D([206,209,187],1); -ELEMENTS[1412] = Fluid2D([235,206,222],1); -ELEMENTS[1413] = Fluid2D([803,757,742],1); -ELEMENTS[1414] = Fluid2D([318,298,279],1); -ELEMENTS[1415] = Fluid2D([4036,4048,4027],1); -ELEMENTS[1416] = Fluid2D([4036,4027,4005],1); -ELEMENTS[1417] = Fluid2D([4027,4035,4011],1); -ELEMENTS[1418] = Fluid2D([224,239,210],1); -ELEMENTS[1419] = Fluid2D([224,210,191],1); -ELEMENTS[1420] = Fluid2D([188,169,170],1); -ELEMENTS[1421] = Fluid2D([4012,4019,3992],1); -ELEMENTS[1422] = Fluid2D([3992,4019,4015],1); -ELEMENTS[1423] = Fluid2D([4052,4084,4074],1); -ELEMENTS[1424] = Fluid2D([4285,4293,4286],1); -ELEMENTS[1425] = Fluid2D([3951,3925,3944],1); -ELEMENTS[1426] = Fluid2D([498,451,483],1); -ELEMENTS[1427] = Fluid2D([3979,3989,3960],1); -ELEMENTS[1428] = Fluid2D([3914,3926,3899],1); -ELEMENTS[1429] = Fluid2D([619,568,599],1); -ELEMENTS[1430] = Fluid2D([3983,3992,3964],1); -ELEMENTS[1431] = Fluid2D([1656,1639,1616],1); -ELEMENTS[1432] = Fluid2D([1616,1639,1599],1); -ELEMENTS[1433] = Fluid2D([1616,1599,1576],1); -ELEMENTS[1434] = Fluid2D([1599,1639,1622],1); -ELEMENTS[1435] = Fluid2D([1599,1622,1582],1); -ELEMENTS[1436] = Fluid2D([1582,1622,1602],1); -ELEMENTS[1437] = Fluid2D([1582,1602,1561],1); -ELEMENTS[1438] = Fluid2D([1576,1599,1558],1); -ELEMENTS[1439] = Fluid2D([1558,1599,1582],1); -ELEMENTS[1440] = Fluid2D([1558,1582,1541],1); -ELEMENTS[1441] = Fluid2D([1541,1582,1561],1); -ELEMENTS[1442] = Fluid2D([1561,1602,1584],1); -ELEMENTS[1443] = Fluid2D([1561,1584,1543],1); -ELEMENTS[1444] = Fluid2D([1543,1584,1566],1); -ELEMENTS[1445] = Fluid2D([1561,1543,1520],1); -ELEMENTS[1446] = Fluid2D([1520,1543,1501],1); -ELEMENTS[1447] = Fluid2D([1543,1566,1524],1); -ELEMENTS[1448] = Fluid2D([1501,1543,1524],1); -ELEMENTS[1449] = Fluid2D([1501,1524,1481],1); -ELEMENTS[1450] = Fluid2D([1524,1566,1550],1); -ELEMENTS[1451] = Fluid2D([1481,1524,1507],1); -ELEMENTS[1452] = Fluid2D([1507,1524,1550],1); -ELEMENTS[1453] = Fluid2D([1481,1507,1465],1); -ELEMENTS[1454] = Fluid2D([1481,1465,1438],1); -ELEMENTS[1455] = Fluid2D([1465,1507,1493],1); -ELEMENTS[1456] = Fluid2D([1493,1507,1534],1); -ELEMENTS[1457] = Fluid2D([1534,1507,1550],1); -ELEMENTS[1458] = Fluid2D([1465,1493,1449],1); -ELEMENTS[1459] = Fluid2D([1449,1493,1474],1); -ELEMENTS[1460] = Fluid2D([1474,1493,1517],1); -ELEMENTS[1461] = Fluid2D([1517,1493,1534],1); -ELEMENTS[1462] = Fluid2D([1449,1474,1431],1); -ELEMENTS[1463] = Fluid2D([1431,1474,1457],1); -ELEMENTS[1464] = Fluid2D([1457,1474,1500],1); -ELEMENTS[1465] = Fluid2D([1431,1457,1412],1); -ELEMENTS[1466] = Fluid2D([1412,1457,1437],1); -ELEMENTS[1467] = Fluid2D([1437,1457,1480],1); -ELEMENTS[1468] = Fluid2D([1438,1465,1421],1); -ELEMENTS[1469] = Fluid2D([1421,1465,1449],1); -ELEMENTS[1470] = Fluid2D([1500,1474,1517],1); -ELEMENTS[1471] = Fluid2D([1480,1457,1500],1); -ELEMENTS[1472] = Fluid2D([1593,1621,1632],1); -ELEMENTS[1473] = Fluid2D([1632,1621,1661],1); -ELEMENTS[1474] = Fluid2D([1632,1661,1670],1); -ELEMENTS[1475] = Fluid2D([1661,1621,1646],1); -ELEMENTS[1476] = Fluid2D([1661,1646,1685],1); -ELEMENTS[1477] = Fluid2D([1685,1646,1676],1); -ELEMENTS[1478] = Fluid2D([1685,1676,1714],1); -ELEMENTS[1479] = Fluid2D([1714,1676,1701],1); -ELEMENTS[1480] = Fluid2D([1714,1701,1739],1); -ELEMENTS[1481] = Fluid2D([1739,1701,1725],1); -ELEMENTS[1482] = Fluid2D([1670,1661,1699],1); -ELEMENTS[1483] = Fluid2D([1670,1699,1707],1); -ELEMENTS[1484] = Fluid2D([1699,1661,1685],1); -ELEMENTS[1485] = Fluid2D([1707,1699,1735],1); -ELEMENTS[1486] = Fluid2D([1707,1735,1744],1); -ELEMENTS[1487] = Fluid2D([1735,1699,1723],1); -ELEMENTS[1488] = Fluid2D([1723,1699,1685],1); -ELEMENTS[1489] = Fluid2D([1744,1735,1772],1); -ELEMENTS[1490] = Fluid2D([1744,1772,1782],1); -ELEMENTS[1491] = Fluid2D([1772,1735,1760],1); -ELEMENTS[1492] = Fluid2D([1760,1735,1723],1); -ELEMENTS[1493] = Fluid2D([1760,1723,1749],1); -ELEMENTS[1494] = Fluid2D([1749,1723,1714],1); -ELEMENTS[1495] = Fluid2D([1714,1723,1685],1); -ELEMENTS[1496] = Fluid2D([1782,1772,1810],1); -ELEMENTS[1497] = Fluid2D([1810,1772,1796],1); -ELEMENTS[1498] = Fluid2D([1796,1772,1760],1); -ELEMENTS[1499] = Fluid2D([1810,1796,1831],1); -ELEMENTS[1500] = Fluid2D([1796,1760,1785],1); -ELEMENTS[1501] = Fluid2D([1785,1760,1749],1); -ELEMENTS[1502] = Fluid2D([1831,1796,1820],1); -ELEMENTS[1503] = Fluid2D([1820,1796,1785],1); -ELEMENTS[1504] = Fluid2D([1785,1749,1776],1); -ELEMENTS[1505] = Fluid2D([1776,1749,1739],1); -ELEMENTS[1506] = Fluid2D([1739,1749,1714],1); -ELEMENTS[1507] = Fluid2D([1820,1785,1813],1); -ELEMENTS[1508] = Fluid2D([1820,1813,1841],1); -ELEMENTS[1509] = Fluid2D([1841,1813,1835],1); -ELEMENTS[1510] = Fluid2D([1835,1813,1799],1); -ELEMENTS[1511] = Fluid2D([1841,1835,1868],1); -ELEMENTS[1512] = Fluid2D([1799,1813,1776],1); -ELEMENTS[1513] = Fluid2D([1868,1835,1860],1); -ELEMENTS[1514] = Fluid2D([1860,1835,1826],1); -ELEMENTS[1515] = Fluid2D([1776,1813,1785],1); -ELEMENTS[1516] = Fluid2D([1826,1835,1799],1); -ELEMENTS[1517] = Fluid2D([1739,1725,1762],1); -ELEMENTS[1518] = Fluid2D([1739,1762,1776],1); -ELEMENTS[1519] = Fluid2D([1776,1762,1799],1); -ELEMENTS[1520] = Fluid2D([1799,1762,1791],1); -ELEMENTS[1521] = Fluid2D([1791,1762,1753],1); -ELEMENTS[1522] = Fluid2D([1762,1725,1753],1); -ELEMENTS[1523] = Fluid2D([1791,1753,1779],1); -ELEMENTS[1524] = Fluid2D([1791,1779,1816],1); -ELEMENTS[1525] = Fluid2D([1791,1816,1826],1); -ELEMENTS[1526] = Fluid2D([1816,1779,1809],1); -ELEMENTS[1527] = Fluid2D([1791,1826,1799],1); -ELEMENTS[1528] = Fluid2D([1826,1816,1850],1); -ELEMENTS[1529] = Fluid2D([1850,1816,1843],1); -ELEMENTS[1530] = Fluid2D([1843,1816,1809],1); -ELEMENTS[1531] = Fluid2D([1850,1843,1874],1); -ELEMENTS[1532] = Fluid2D([1850,1874,1884],1); -ELEMENTS[1533] = Fluid2D([1874,1843,1867],1); -ELEMENTS[1534] = Fluid2D([1867,1843,1833],1); -ELEMENTS[1535] = Fluid2D([1833,1843,1809],1); -ELEMENTS[1536] = Fluid2D([1874,1867,1899],1); -ELEMENTS[1537] = Fluid2D([1884,1874,1908],1); -ELEMENTS[1538] = Fluid2D([1884,1908,1916],1); -ELEMENTS[1539] = Fluid2D([1908,1874,1899],1); -ELEMENTS[1540] = Fluid2D([1899,1867,1890],1); -ELEMENTS[1541] = Fluid2D([1890,1867,1856],1); -ELEMENTS[1542] = Fluid2D([1856,1867,1833],1); -ELEMENTS[1543] = Fluid2D([1899,1890,1923],1); -ELEMENTS[1544] = Fluid2D([1899,1923,1930],1); -ELEMENTS[1545] = Fluid2D([1930,1923,1957],1); -ELEMENTS[1546] = Fluid2D([1930,1957,1968],1); -ELEMENTS[1547] = Fluid2D([1957,1923,1948],1); -ELEMENTS[1548] = Fluid2D([1948,1923,1914],1); -ELEMENTS[1549] = Fluid2D([1968,1957,1996],1); -ELEMENTS[1550] = Fluid2D([1996,1957,1990],1); -ELEMENTS[1551] = Fluid2D([1990,1957,1948],1); -ELEMENTS[1552] = Fluid2D([1990,1948,1980],1); -ELEMENTS[1553] = Fluid2D([1980,1948,1939],1); -ELEMENTS[1554] = Fluid2D([1914,1923,1890],1); -ELEMENTS[1555] = Fluid2D([1916,1908,1940],1); -ELEMENTS[1556] = Fluid2D([1916,1940,1949],1); -ELEMENTS[1557] = Fluid2D([1940,1908,1930],1); -ELEMENTS[1558] = Fluid2D([1930,1908,1899],1); -ELEMENTS[1559] = Fluid2D([1939,1948,1914],1); -ELEMENTS[1560] = Fluid2D([1939,1914,1907],1); -ELEMENTS[1561] = Fluid2D([1949,1940,1982],1); -ELEMENTS[1562] = Fluid2D([1982,1940,1968],1); -ELEMENTS[1563] = Fluid2D([1968,1940,1930],1); -ELEMENTS[1564] = Fluid2D([1907,1914,1882],1); -ELEMENTS[1565] = Fluid2D([1882,1914,1890],1); -ELEMENTS[1566] = Fluid2D([1882,1890,1856],1); -ELEMENTS[1567] = Fluid2D([1593,1632,1604],1); -ELEMENTS[1568] = Fluid2D([1604,1632,1643],1); -ELEMENTS[1569] = Fluid2D([1643,1632,1670],1); -ELEMENTS[1570] = Fluid2D([1643,1670,1682],1); -ELEMENTS[1571] = Fluid2D([1593,1604,1564],1); -ELEMENTS[1572] = Fluid2D([1682,1670,1707],1); -ELEMENTS[1573] = Fluid2D([1682,1707,1720],1); -ELEMENTS[1574] = Fluid2D([1720,1707,1744],1); -ELEMENTS[1575] = Fluid2D([1564,1604,1579],1); -ELEMENTS[1576] = Fluid2D([1579,1604,1617],1); -ELEMENTS[1577] = Fluid2D([1564,1579,1539],1); -ELEMENTS[1578] = Fluid2D([1617,1604,1643],1); -ELEMENTS[1579] = Fluid2D([1539,1579,1549],1); -ELEMENTS[1580] = Fluid2D([1549,1579,1588],1); -ELEMENTS[1581] = Fluid2D([1588,1579,1617],1); -ELEMENTS[1582] = Fluid2D([1588,1617,1627],1); -ELEMENTS[1583] = Fluid2D([1627,1617,1657],1); -ELEMENTS[1584] = Fluid2D([1627,1657,1666],1); -ELEMENTS[1585] = Fluid2D([1657,1617,1643],1); -ELEMENTS[1586] = Fluid2D([1539,1549,1509],1); -ELEMENTS[1587] = Fluid2D([1666,1657,1695],1); -ELEMENTS[1588] = Fluid2D([1666,1695,1706],1); -ELEMENTS[1589] = Fluid2D([1695,1657,1682],1); -ELEMENTS[1590] = Fluid2D([1682,1657,1643],1); -ELEMENTS[1591] = Fluid2D([1706,1695,1733],1); -ELEMENTS[1592] = Fluid2D([1706,1733,1743],1); -ELEMENTS[1593] = Fluid2D([1733,1695,1720],1); -ELEMENTS[1594] = Fluid2D([1720,1695,1682],1); -ELEMENTS[1595] = Fluid2D([1743,1733,1769],1); -ELEMENTS[1596] = Fluid2D([1769,1733,1758],1); -ELEMENTS[1597] = Fluid2D([1758,1733,1720],1); -ELEMENTS[1598] = Fluid2D([1769,1758,1793],1); -ELEMENTS[1599] = Fluid2D([1769,1793,1806],1); -ELEMENTS[1600] = Fluid2D([1793,1758,1782],1); -ELEMENTS[1601] = Fluid2D([1782,1758,1744],1); -ELEMENTS[1602] = Fluid2D([1806,1793,1829],1); -ELEMENTS[1603] = Fluid2D([1829,1793,1819],1); -ELEMENTS[1604] = Fluid2D([1819,1793,1782],1); -ELEMENTS[1605] = Fluid2D([1829,1819,1853],1); -ELEMENTS[1606] = Fluid2D([1829,1853,1864],1); -ELEMENTS[1607] = Fluid2D([1853,1819,1848],1); -ELEMENTS[1608] = Fluid2D([1848,1819,1810],1); -ELEMENTS[1609] = Fluid2D([1864,1853,1895],1); -ELEMENTS[1610] = Fluid2D([1895,1853,1886],1); -ELEMENTS[1611] = Fluid2D([1886,1853,1848],1); -ELEMENTS[1612] = Fluid2D([1509,1549,1522],1); -ELEMENTS[1613] = Fluid2D([1522,1549,1562],1); -ELEMENTS[1614] = Fluid2D([1509,1522,1479],1); -ELEMENTS[1615] = Fluid2D([1479,1522,1497],1); -ELEMENTS[1616] = Fluid2D([1497,1522,1538],1); -ELEMENTS[1617] = Fluid2D([1538,1522,1562],1); -ELEMENTS[1618] = Fluid2D([1562,1549,1588],1); -ELEMENTS[1619] = Fluid2D([1744,1758,1720],1); -ELEMENTS[1620] = Fluid2D([1810,1819,1782],1); -ELEMENTS[1621] = Fluid2D([1538,1562,1578],1); -ELEMENTS[1622] = Fluid2D([1538,1578,1551],1); -ELEMENTS[1623] = Fluid2D([1551,1578,1591],1); -ELEMENTS[1624] = Fluid2D([1591,1578,1618],1); -ELEMENTS[1625] = Fluid2D([1618,1578,1603],1); -ELEMENTS[1626] = Fluid2D([1603,1578,1562],1); -ELEMENTS[1627] = Fluid2D([1603,1562,1588],1); -ELEMENTS[1628] = Fluid2D([1538,1551,1510],1); -ELEMENTS[1629] = Fluid2D([1510,1551,1523],1); -ELEMENTS[1630] = Fluid2D([1523,1551,1565],1); -ELEMENTS[1631] = Fluid2D([1618,1603,1642],1); -ELEMENTS[1632] = Fluid2D([1642,1603,1627],1); -ELEMENTS[1633] = Fluid2D([1510,1523,1484],1); -ELEMENTS[1634] = Fluid2D([1484,1523,1491],1); -ELEMENTS[1635] = Fluid2D([1491,1523,1540],1); -ELEMENTS[1636] = Fluid2D([1565,1551,1591],1); -ELEMENTS[1637] = Fluid2D([1565,1591,1606],1); -ELEMENTS[1638] = Fluid2D([1606,1591,1630],1); -ELEMENTS[1639] = Fluid2D([1540,1523,1565],1); -ELEMENTS[1640] = Fluid2D([1540,1565,1581],1); -ELEMENTS[1641] = Fluid2D([1581,1565,1606],1); -ELEMENTS[1642] = Fluid2D([1581,1606,1623],1); -ELEMENTS[1643] = Fluid2D([1623,1606,1645],1); -ELEMENTS[1644] = Fluid2D([1645,1606,1630],1); -ELEMENTS[1645] = Fluid2D([1630,1591,1618],1); -ELEMENTS[1646] = Fluid2D([1630,1618,1658],1); -ELEMENTS[1647] = Fluid2D([1658,1618,1642],1); -ELEMENTS[1648] = Fluid2D([1658,1642,1681],1); -ELEMENTS[1649] = Fluid2D([1681,1642,1666],1); -ELEMENTS[1650] = Fluid2D([1603,1588,1627],1); -ELEMENTS[1651] = Fluid2D([1681,1666,1706],1); -ELEMENTS[1652] = Fluid2D([1666,1642,1627],1); -ELEMENTS[1653] = Fluid2D([1681,1706,1719],1); -ELEMENTS[1654] = Fluid2D([1681,1719,1696],1); -ELEMENTS[1655] = Fluid2D([1696,1719,1734],1); -ELEMENTS[1656] = Fluid2D([1696,1734,1708],1); -ELEMENTS[1657] = Fluid2D([1734,1719,1757],1); -ELEMENTS[1658] = Fluid2D([1757,1719,1743],1); -ELEMENTS[1659] = Fluid2D([1734,1757,1771],1); -ELEMENTS[1660] = Fluid2D([1734,1771,1745],1); -ELEMENTS[1661] = Fluid2D([1745,1771,1783],1); -ELEMENTS[1662] = Fluid2D([1771,1757,1795],1); -ELEMENTS[1663] = Fluid2D([1783,1771,1808],1); -ELEMENTS[1664] = Fluid2D([1808,1771,1795],1); -ELEMENTS[1665] = Fluid2D([1795,1757,1781],1); -ELEMENTS[1666] = Fluid2D([1781,1757,1743],1); -ELEMENTS[1667] = Fluid2D([1795,1781,1817],1); -ELEMENTS[1668] = Fluid2D([1795,1817,1836],1); -ELEMENTS[1669] = Fluid2D([1836,1817,1863],1); -ELEMENTS[1670] = Fluid2D([1863,1817,1842],1); -ELEMENTS[1671] = Fluid2D([1842,1817,1806],1); -ELEMENTS[1672] = Fluid2D([1806,1817,1781],1); -ELEMENTS[1673] = Fluid2D([1708,1734,1745],1); -ELEMENTS[1674] = Fluid2D([1708,1745,1721],1); -ELEMENTS[1675] = Fluid2D([1721,1745,1759],1); -ELEMENTS[1676] = Fluid2D([1759,1745,1783],1); -ELEMENTS[1677] = Fluid2D([1721,1759,1738],1); -ELEMENTS[1678] = Fluid2D([1738,1759,1775],1); -ELEMENTS[1679] = Fluid2D([1775,1759,1797],1); -ELEMENTS[1680] = Fluid2D([1797,1759,1783],1); -ELEMENTS[1681] = Fluid2D([1797,1783,1821],1); -ELEMENTS[1682] = Fluid2D([1821,1783,1808],1); -ELEMENTS[1683] = Fluid2D([1821,1808,1852],1); -ELEMENTS[1684] = Fluid2D([1852,1808,1836],1); -ELEMENTS[1685] = Fluid2D([1721,1738,1702],1); -ELEMENTS[1686] = Fluid2D([1702,1738,1704],1); -ELEMENTS[1687] = Fluid2D([1704,1738,1756],1); -ELEMENTS[1688] = Fluid2D([1756,1738,1775],1); -ELEMENTS[1689] = Fluid2D([1806,1781,1769],1); -ELEMENTS[1690] = Fluid2D([1769,1781,1743],1); -ELEMENTS[1691] = Fluid2D([1743,1719,1706],1); -ELEMENTS[1692] = Fluid2D([1836,1808,1795],1); -ELEMENTS[1693] = Fluid2D([876,811,860],1); -ELEMENTS[1694] = Fluid2D([876,860,924],1); -ELEMENTS[1695] = Fluid2D([860,811,797],1); -ELEMENTS[1696] = Fluid2D([924,860,913],1); -ELEMENTS[1697] = Fluid2D([860,797,850],1); -ELEMENTS[1698] = Fluid2D([797,811,751],1); -ELEMENTS[1699] = Fluid2D([860,850,913],1); -ELEMENTS[1700] = Fluid2D([850,797,788],1); -ELEMENTS[1701] = Fluid2D([751,811,763],1); -ELEMENTS[1702] = Fluid2D([763,811,825],1); -ELEMENTS[1703] = Fluid2D([751,763,705],1); -ELEMENTS[1704] = Fluid2D([850,788,840],1); -ELEMENTS[1705] = Fluid2D([788,797,739],1); -ELEMENTS[1706] = Fluid2D([739,797,751],1); -ELEMENTS[1707] = Fluid2D([850,840,901],1); -ELEMENTS[1708] = Fluid2D([840,788,779],1); -ELEMENTS[1709] = Fluid2D([779,788,730],1); -ELEMENTS[1710] = Fluid2D([901,840,893],1); -ELEMENTS[1711] = Fluid2D([730,788,739],1); -ELEMENTS[1712] = Fluid2D([893,840,827],1); -ELEMENTS[1713] = Fluid2D([893,827,881],1); -ELEMENTS[1714] = Fluid2D([827,840,779],1); -ELEMENTS[1715] = Fluid2D([881,827,818],1); -ELEMENTS[1716] = Fluid2D([881,818,871],1); -ELEMENTS[1717] = Fluid2D([818,827,769],1); -ELEMENTS[1718] = Fluid2D([871,818,809],1); -ELEMENTS[1719] = Fluid2D([769,827,779],1); -ELEMENTS[1720] = Fluid2D([809,818,761],1); -ELEMENTS[1721] = Fluid2D([761,818,769],1); -ELEMENTS[1722] = Fluid2D([809,761,750],1); -ELEMENTS[1723] = Fluid2D([809,750,812],1); -ELEMENTS[1724] = Fluid2D([750,761,703],1); -ELEMENTS[1725] = Fluid2D([703,761,709],1); -ELEMENTS[1726] = Fluid2D([812,750,743],1); -ELEMENTS[1727] = Fluid2D([709,761,769],1); -ELEMENTS[1728] = Fluid2D([743,750,693],1); -ELEMENTS[1729] = Fluid2D([743,693,699],1); -ELEMENTS[1730] = Fluid2D([693,750,703],1); -ELEMENTS[1731] = Fluid2D([699,693,641],1); -ELEMENTS[1732] = Fluid2D([699,641,631],1); -ELEMENTS[1733] = Fluid2D([631,641,591],1); -ELEMENTS[1734] = Fluid2D([591,641,598],1); -ELEMENTS[1735] = Fluid2D([641,693,648],1); -ELEMENTS[1736] = Fluid2D([648,693,703],1); -ELEMENTS[1737] = Fluid2D([598,641,648],1); -ELEMENTS[1738] = Fluid2D([598,648,601],1); -ELEMENTS[1739] = Fluid2D([601,648,653],1); -ELEMENTS[1740] = Fluid2D([653,648,703],1); -ELEMENTS[1741] = Fluid2D([598,601,555],1); -ELEMENTS[1742] = Fluid2D([555,601,561],1); -ELEMENTS[1743] = Fluid2D([561,601,610],1); -ELEMENTS[1744] = Fluid2D([610,601,653],1); -ELEMENTS[1745] = Fluid2D([598,555,551],1); -ELEMENTS[1746] = Fluid2D([610,653,660],1); -ELEMENTS[1747] = Fluid2D([660,653,709],1); -ELEMENTS[1748] = Fluid2D([551,555,513],1); -ELEMENTS[1749] = Fluid2D([513,555,517],1); -ELEMENTS[1750] = Fluid2D([517,555,561],1); -ELEMENTS[1751] = Fluid2D([517,561,532],1); -ELEMENTS[1752] = Fluid2D([532,561,563],1); -ELEMENTS[1753] = Fluid2D([563,561,610],1); -ELEMENTS[1754] = Fluid2D([709,653,703],1); -ELEMENTS[1755] = Fluid2D([739,751,691],1); -ELEMENTS[1756] = Fluid2D([739,691,681],1); -ELEMENTS[1757] = Fluid2D([681,691,639],1); -ELEMENTS[1758] = Fluid2D([639,691,649],1); -ELEMENTS[1759] = Fluid2D([649,691,705],1); -ELEMENTS[1760] = Fluid2D([649,705,658],1); -ELEMENTS[1761] = Fluid2D([639,649,597],1); -ELEMENTS[1762] = Fluid2D([597,649,605],1); -ELEMENTS[1763] = Fluid2D([605,649,658],1); -ELEMENTS[1764] = Fluid2D([597,605,544],1); -ELEMENTS[1765] = Fluid2D([544,605,569],1); -ELEMENTS[1766] = Fluid2D([569,605,618],1); -ELEMENTS[1767] = Fluid2D([691,751,705],1); -ELEMENTS[1768] = Fluid2D([913,850,901],1); -ELEMENTS[1769] = Fluid2D([913,901,967],1); -ELEMENTS[1770] = Fluid2D([967,901,954],1); -ELEMENTS[1771] = Fluid2D([954,901,893],1); -ELEMENTS[1772] = Fluid2D([954,893,947],1); -ELEMENTS[1773] = Fluid2D([954,947,1014],1); -ELEMENTS[1774] = Fluid2D([1014,947,998],1); -ELEMENTS[1775] = Fluid2D([998,947,933],1); -ELEMENTS[1776] = Fluid2D([998,933,988],1); -ELEMENTS[1777] = Fluid2D([988,933,923],1); -ELEMENTS[1778] = Fluid2D([923,933,871],1); -ELEMENTS[1779] = Fluid2D([871,933,881],1); -ELEMENTS[1780] = Fluid2D([881,933,947],1); -ELEMENTS[1781] = Fluid2D([947,893,881],1); -ELEMENTS[1782] = Fluid2D([605,658,618],1); -ELEMENTS[1783] = Fluid2D([913,967,979],1); -ELEMENTS[1784] = Fluid2D([913,979,924],1); -ELEMENTS[1785] = Fluid2D([979,967,1030],1); -ELEMENTS[1786] = Fluid2D([1030,967,1023],1); -ELEMENTS[1787] = Fluid2D([1023,967,954],1); -ELEMENTS[1788] = Fluid2D([1023,954,1014],1); -ELEMENTS[1789] = Fluid2D([1023,1014,1074],1); -ELEMENTS[1790] = Fluid2D([1074,1014,1065],1); -ELEMENTS[1791] = Fluid2D([1065,1014,998],1); -ELEMENTS[1792] = Fluid2D([1030,1023,1090],1); -ELEMENTS[1793] = Fluid2D([1090,1023,1074],1); -ELEMENTS[1794] = Fluid2D([1090,1074,1134],1); -ELEMENTS[1795] = Fluid2D([1134,1074,1129],1); -ELEMENTS[1796] = Fluid2D([1129,1074,1065],1); -ELEMENTS[1797] = Fluid2D([1129,1065,1118],1); -ELEMENTS[1798] = Fluid2D([1118,1065,1056],1); -ELEMENTS[1799] = Fluid2D([1118,1056,1106],1); -ELEMENTS[1800] = Fluid2D([1106,1056,1042],1); -ELEMENTS[1801] = Fluid2D([1042,1056,988],1); -ELEMENTS[1802] = Fluid2D([988,1056,998],1); -ELEMENTS[1803] = Fluid2D([998,1056,1065],1); -ELEMENTS[1804] = Fluid2D([1030,1090,1100],1); -ELEMENTS[1805] = Fluid2D([1100,1090,1146],1); -ELEMENTS[1806] = Fluid2D([1146,1090,1134],1); -ELEMENTS[1807] = Fluid2D([1146,1134,1188],1); -ELEMENTS[1808] = Fluid2D([1188,1134,1169],1); -ELEMENTS[1809] = Fluid2D([1169,1134,1129],1); -ELEMENTS[1810] = Fluid2D([1188,1220,1258],1); -ELEMENTS[1811] = Fluid2D([924,979,992],1); -ELEMENTS[1812] = Fluid2D([992,979,1040],1); -ELEMENTS[1813] = Fluid2D([992,1040,1060],1); -ELEMENTS[1814] = Fluid2D([1060,1040,1107],1); -ELEMENTS[1815] = Fluid2D([1107,1040,1100],1); -ELEMENTS[1816] = Fluid2D([1040,979,1030],1); -ELEMENTS[1817] = Fluid2D([924,992,940],1); -ELEMENTS[1818] = Fluid2D([1100,1040,1030],1); -ELEMENTS[1819] = Fluid2D([924,940,876],1); -ELEMENTS[1820] = Fluid2D([940,992,1005],1); -ELEMENTS[1821] = Fluid2D([1005,992,1060],1); -ELEMENTS[1822] = Fluid2D([1005,1060,1071],1); -ELEMENTS[1823] = Fluid2D([1005,1071,1021],1); -ELEMENTS[1824] = Fluid2D([1021,1071,1089],1); -ELEMENTS[1825] = Fluid2D([1021,1089,1031],1); -ELEMENTS[1826] = Fluid2D([1021,1031,968],1); -ELEMENTS[1827] = Fluid2D([1031,1089,1109],1); -ELEMENTS[1828] = Fluid2D([1021,968,953],1); -ELEMENTS[1829] = Fluid2D([953,968,900],1); -ELEMENTS[1830] = Fluid2D([1109,1089,1184],1); -ELEMENTS[1831] = Fluid2D([1031,1109,1052],1); -ELEMENTS[1832] = Fluid2D([1052,1109,1121],1); -ELEMENTS[1833] = Fluid2D([1052,1121,1088],1); -ELEMENTS[1834] = Fluid2D([1121,1109,1173],1); -ELEMENTS[1835] = Fluid2D([1089,1071,1149],1); -ELEMENTS[1836] = Fluid2D([1089,1149,1184],1); -ELEMENTS[1837] = Fluid2D([1149,1071,1125],1); -ELEMENTS[1838] = Fluid2D([1125,1071,1060],1); -ELEMENTS[1839] = Fluid2D([1125,1060,1107],1); -ELEMENTS[1840] = Fluid2D([1125,1107,1165],1); -ELEMENTS[1841] = Fluid2D([1125,1165,1207],1); -ELEMENTS[1842] = Fluid2D([1165,1107,1157],1); -ELEMENTS[1843] = Fluid2D([1165,1157,1218],1); -ELEMENTS[1844] = Fluid2D([1157,1107,1100],1); -ELEMENTS[1845] = Fluid2D([1157,1100,1146],1); -ELEMENTS[1846] = Fluid2D([1149,1125,1207],1); -ELEMENTS[1847] = Fluid2D([1157,1146,1193],1); -ELEMENTS[1848] = Fluid2D([1157,1193,1233],1); -ELEMENTS[1849] = Fluid2D([1233,1193,1244],1); -ELEMENTS[1850] = Fluid2D([1244,1193,1188],1); -ELEMENTS[1851] = Fluid2D([1193,1146,1188],1); -ELEMENTS[1852] = Fluid2D([940,1005,953],1); -ELEMENTS[1853] = Fluid2D([940,953,886],1); -ELEMENTS[1854] = Fluid2D([953,1005,1021],1); -ELEMENTS[1855] = Fluid2D([179,184,198],1); -ELEMENTS[1856] = Fluid2D([2939,2918,2912],1); -ELEMENTS[1857] = Fluid2D([2912,2918,2890],1); -ELEMENTS[1858] = Fluid2D([2890,2918,2896],1); -ELEMENTS[1859] = Fluid2D([2890,2896,2869],1); -ELEMENTS[1860] = Fluid2D([2890,2869,2862],1); -ELEMENTS[1861] = Fluid2D([2869,2896,2876],1); -ELEMENTS[1862] = Fluid2D([2869,2876,2850],1); -ELEMENTS[1863] = Fluid2D([2869,2850,2840],1); -ELEMENTS[1864] = Fluid2D([2850,2876,2855],1); -ELEMENTS[1865] = Fluid2D([2850,2855,2827],1); -ELEMENTS[1866] = Fluid2D([2827,2855,2832],1); -ELEMENTS[1867] = Fluid2D([2827,2832,2805],1); -ELEMENTS[1868] = Fluid2D([2805,2832,2811],1); -ELEMENTS[1869] = Fluid2D([2805,2811,2783],1); -ELEMENTS[1870] = Fluid2D([2783,2811,2789],1); -ELEMENTS[1871] = Fluid2D([2939,2912,2933],1); -ELEMENTS[1872] = Fluid2D([2933,2912,2907],1); -ELEMENTS[1873] = Fluid2D([2939,2933,2959],1); -ELEMENTS[1874] = Fluid2D([2907,2912,2885],1); -ELEMENTS[1875] = Fluid2D([2907,2885,2881],1); -ELEMENTS[1876] = Fluid2D([2862,2869,2840],1); -ELEMENTS[1877] = Fluid2D([2862,2840,2836],1); -ELEMENTS[1878] = Fluid2D([2840,2850,2820],1); -ELEMENTS[1879] = Fluid2D([2820,2850,2827],1); -ELEMENTS[1880] = Fluid2D([2881,2885,2858],1); -ELEMENTS[1881] = Fluid2D([2881,2858,2853],1); -ELEMENTS[1882] = Fluid2D([2858,2885,2862],1); -ELEMENTS[1883] = Fluid2D([2862,2885,2890],1); -ELEMENTS[1884] = Fluid2D([2890,2885,2912],1); -ELEMENTS[1885] = Fluid2D([2836,2840,2813],1); -ELEMENTS[1886] = Fluid2D([2813,2840,2820],1); -ELEMENTS[1887] = Fluid2D([2813,2820,2792],1); -ELEMENTS[1888] = Fluid2D([2813,2792,2786],1); -ELEMENTS[1889] = Fluid2D([2792,2820,2800],1); -ELEMENTS[1890] = Fluid2D([2800,2820,2827],1); -ELEMENTS[1891] = Fluid2D([2800,2827,2805],1); -ELEMENTS[1892] = Fluid2D([2800,2805,2778],1); -ELEMENTS[1893] = Fluid2D([2778,2805,2783],1); -ELEMENTS[1894] = Fluid2D([2786,2792,2764],1); -ELEMENTS[1895] = Fluid2D([2786,2764,2758],1); -ELEMENTS[1896] = Fluid2D([2764,2792,2771],1); -ELEMENTS[1897] = Fluid2D([2771,2792,2800],1); -ELEMENTS[1898] = Fluid2D([2758,2764,2737],1); -ELEMENTS[1899] = Fluid2D([2758,2737,2732],1); -ELEMENTS[1900] = Fluid2D([2737,2764,2741],1); -ELEMENTS[1901] = Fluid2D([2741,2764,2771],1); -ELEMENTS[1902] = Fluid2D([2741,2771,2750],1); -ELEMENTS[1903] = Fluid2D([2750,2771,2778],1); -ELEMENTS[1904] = Fluid2D([2778,2771,2800],1); -ELEMENTS[1905] = Fluid2D([2853,2858,2831],1); -ELEMENTS[1906] = Fluid2D([2853,2831,2826],1); -ELEMENTS[1907] = Fluid2D([2831,2858,2836],1); -ELEMENTS[1908] = Fluid2D([2836,2858,2862],1); -ELEMENTS[1909] = Fluid2D([2826,2831,2804],1); -ELEMENTS[1910] = Fluid2D([2826,2804,2799],1); -ELEMENTS[1911] = Fluid2D([2804,2831,2808],1); -ELEMENTS[1912] = Fluid2D([2808,2831,2836],1); -ELEMENTS[1913] = Fluid2D([2808,2836,2813],1); -ELEMENTS[1914] = Fluid2D([2808,2813,2786],1); -ELEMENTS[1915] = Fluid2D([2732,2737,2710],1); -ELEMENTS[1916] = Fluid2D([2732,2710,2704],1); -ELEMENTS[1917] = Fluid2D([2710,2737,2714],1); -ELEMENTS[1918] = Fluid2D([2714,2737,2741],1); -ELEMENTS[1919] = Fluid2D([2714,2741,2721],1); -ELEMENTS[1920] = Fluid2D([2721,2741,2750],1); -ELEMENTS[1921] = Fluid2D([2721,2750,2728],1); -ELEMENTS[1922] = Fluid2D([2728,2750,2755],1); -ELEMENTS[1923] = Fluid2D([2755,2750,2778],1); -ELEMENTS[1924] = Fluid2D([2799,2804,2776],1); -ELEMENTS[1925] = Fluid2D([2799,2776,2770],1); -ELEMENTS[1926] = Fluid2D([2776,2804,2781],1); -ELEMENTS[1927] = Fluid2D([2776,2781,2754],1); -ELEMENTS[1928] = Fluid2D([2754,2781,2758],1); -ELEMENTS[1929] = Fluid2D([2758,2781,2786],1); -ELEMENTS[1930] = Fluid2D([2786,2781,2808],1); -ELEMENTS[1931] = Fluid2D([2770,2776,2749],1); -ELEMENTS[1932] = Fluid2D([2749,2776,2754],1); -ELEMENTS[1933] = Fluid2D([2749,2754,2727],1); -ELEMENTS[1934] = Fluid2D([2727,2754,2732],1); -ELEMENTS[1935] = Fluid2D([2732,2754,2758],1); -ELEMENTS[1936] = Fluid2D([2727,2732,2704],1); -ELEMENTS[1937] = Fluid2D([2727,2704,2697],1); -ELEMENTS[1938] = Fluid2D([2697,2704,2676],1); -ELEMENTS[1939] = Fluid2D([2697,2676,2669],1); -ELEMENTS[1940] = Fluid2D([2676,2704,2681],1); -ELEMENTS[1941] = Fluid2D([2681,2704,2710],1); -ELEMENTS[1942] = Fluid2D([2669,2676,2648],1); -ELEMENTS[1943] = Fluid2D([2669,2648,2643],1); -ELEMENTS[1944] = Fluid2D([2648,2676,2653],1); -ELEMENTS[1945] = Fluid2D([2653,2676,2681],1); -ELEMENTS[1946] = Fluid2D([2643,2648,2619],1); -ELEMENTS[1947] = Fluid2D([2643,2619,2614],1); -ELEMENTS[1948] = Fluid2D([2619,2648,2624],1); -ELEMENTS[1949] = Fluid2D([2624,2648,2653],1); -ELEMENTS[1950] = Fluid2D([2624,2653,2631],1); -ELEMENTS[1951] = Fluid2D([2631,2653,2659],1); -ELEMENTS[1952] = Fluid2D([2659,2653,2681],1); -ELEMENTS[1953] = Fluid2D([2659,2681,2687],1); -ELEMENTS[1954] = Fluid2D([2687,2681,2710],1); -ELEMENTS[1955] = Fluid2D([2614,2619,2592],1); -ELEMENTS[1956] = Fluid2D([2614,2592,2587],1); -ELEMENTS[1957] = Fluid2D([2592,2619,2595],1); -ELEMENTS[1958] = Fluid2D([2595,2619,2624],1); -ELEMENTS[1959] = Fluid2D([2587,2592,2564],1); -ELEMENTS[1960] = Fluid2D([2587,2564,2559],1); -ELEMENTS[1961] = Fluid2D([2564,2592,2567],1); -ELEMENTS[1962] = Fluid2D([2567,2592,2595],1); -ELEMENTS[1963] = Fluid2D([2567,2595,2572],1); -ELEMENTS[1964] = Fluid2D([2572,2595,2602],1); -ELEMENTS[1965] = Fluid2D([2602,2595,2624],1); -ELEMENTS[1966] = Fluid2D([2559,2564,2534],1); -ELEMENTS[1967] = Fluid2D([2559,2534,2530],1); -ELEMENTS[1968] = Fluid2D([2534,2564,2540],1); -ELEMENTS[1969] = Fluid2D([2540,2564,2567],1); -ELEMENTS[1970] = Fluid2D([2530,2534,2506],1); -ELEMENTS[1971] = Fluid2D([2530,2506,2500],1); -ELEMENTS[1972] = Fluid2D([2506,2534,2512],1); -ELEMENTS[1973] = Fluid2D([2512,2534,2540],1); -ELEMENTS[1974] = Fluid2D([2500,2506,2477],1); -ELEMENTS[1975] = Fluid2D([2500,2477,2471],1); -ELEMENTS[1976] = Fluid2D([2477,2506,2483],1); -ELEMENTS[1977] = Fluid2D([2483,2506,2512],1); -ELEMENTS[1978] = Fluid2D([2471,2477,2448],1); -ELEMENTS[1979] = Fluid2D([2448,2477,2452],1); -ELEMENTS[1980] = Fluid2D([2452,2477,2483],1); -ELEMENTS[1981] = Fluid2D([2452,2483,2459],1); -ELEMENTS[1982] = Fluid2D([2459,2483,2487],1); -ELEMENTS[1983] = Fluid2D([2483,2512,2487],1); -ELEMENTS[1984] = Fluid2D([2487,2512,2516],1); -ELEMENTS[1985] = Fluid2D([2487,2516,2493],1); -ELEMENTS[1986] = Fluid2D([2493,2516,2523],1); -ELEMENTS[1987] = Fluid2D([2523,2516,2544],1); -ELEMENTS[1988] = Fluid2D([2544,2516,2540],1); -ELEMENTS[1989] = Fluid2D([2540,2516,2512],1); -ELEMENTS[1990] = Fluid2D([2959,2933,2955],1); -ELEMENTS[1991] = Fluid2D([2959,2955,2981],1); -ELEMENTS[1992] = Fluid2D([2981,2955,2977],1); -ELEMENTS[1993] = Fluid2D([2981,2977,3004],1); -ELEMENTS[1994] = Fluid2D([2955,2933,2929],1); -ELEMENTS[1995] = Fluid2D([2929,2933,2907],1); -ELEMENTS[1996] = Fluid2D([2929,2907,2902],1); -ELEMENTS[1997] = Fluid2D([2902,2907,2881],1); -ELEMENTS[1998] = Fluid2D([3004,2977,3000],1); -ELEMENTS[1999] = Fluid2D([3000,2977,2973],1); -ELEMENTS[2000] = Fluid2D([3004,3000,3026],1); -ELEMENTS[2001] = Fluid2D([2973,2977,2951],1); -ELEMENTS[2002] = Fluid2D([2951,2977,2955],1); -ELEMENTS[2003] = Fluid2D([2951,2955,2929],1); -ELEMENTS[2004] = Fluid2D([3026,3000,3021],1); -ELEMENTS[2005] = Fluid2D([3026,3021,3048],1); -ELEMENTS[2006] = Fluid2D([3021,3000,2995],1); -ELEMENTS[2007] = Fluid2D([2995,3000,2973],1); -ELEMENTS[2008] = Fluid2D([3048,3021,3043],1); -ELEMENTS[2009] = Fluid2D([3043,3021,3016],1); -ELEMENTS[2010] = Fluid2D([3016,3021,2995],1); -ELEMENTS[2011] = Fluid2D([3016,2995,2990],1); -ELEMENTS[2012] = Fluid2D([2990,2995,2968],1); -ELEMENTS[2013] = Fluid2D([2990,2968,2963],1); -ELEMENTS[2014] = Fluid2D([2968,2995,2973],1); -ELEMENTS[2015] = Fluid2D([2963,2968,2942],1); -ELEMENTS[2016] = Fluid2D([2942,2968,2946],1); -ELEMENTS[2017] = Fluid2D([2946,2968,2973],1); -ELEMENTS[2018] = Fluid2D([2946,2973,2951],1); -ELEMENTS[2019] = Fluid2D([3048,3043,3069],1); -ELEMENTS[2020] = Fluid2D([3069,3043,3065],1); -ELEMENTS[2021] = Fluid2D([3065,3043,3038],1); -ELEMENTS[2022] = Fluid2D([3038,3043,3016],1); -ELEMENTS[2023] = Fluid2D([3038,3016,3011],1); -ELEMENTS[2024] = Fluid2D([3011,3016,2990],1); -ELEMENTS[2025] = Fluid2D([3065,3038,3059],1); -ELEMENTS[2026] = Fluid2D([3059,3038,3033],1); -ELEMENTS[2027] = Fluid2D([3065,3059,3087],1); -ELEMENTS[2028] = Fluid2D([3087,3059,3081],1); -ELEMENTS[2029] = Fluid2D([3081,3059,3053],1); -ELEMENTS[2030] = Fluid2D([3053,3059,3033],1); -ELEMENTS[2031] = Fluid2D([3033,3038,3011],1); -ELEMENTS[2032] = Fluid2D([3033,3011,3006],1); -ELEMENTS[2033] = Fluid2D([3006,3011,2984],1); -ELEMENTS[2034] = Fluid2D([3033,3006,3028],1); -ELEMENTS[2035] = Fluid2D([3028,3006,3002],1); -ELEMENTS[2036] = Fluid2D([2984,3011,2990],1); -ELEMENTS[2037] = Fluid2D([2984,2990,2963],1); -ELEMENTS[2038] = Fluid2D([2984,2963,2957],1); -ELEMENTS[2039] = Fluid2D([2957,2963,2935],1); -ELEMENTS[2040] = Fluid2D([2935,2963,2942],1); -ELEMENTS[2041] = Fluid2D([2935,2942,2913],1); -ELEMENTS[2042] = Fluid2D([2913,2942,2920],1); -ELEMENTS[2043] = Fluid2D([2920,2942,2946],1); -ELEMENTS[2044] = Fluid2D([3002,3006,2979],1); -ELEMENTS[2045] = Fluid2D([3002,2979,2976],1); -ELEMENTS[2046] = Fluid2D([2979,3006,2984],1); -ELEMENTS[2047] = Fluid2D([2976,2979,2953],1); -ELEMENTS[2048] = Fluid2D([2953,2979,2957],1); -ELEMENTS[2049] = Fluid2D([2957,2979,2984],1); -ELEMENTS[2050] = Fluid2D([2946,2951,2925],1); -ELEMENTS[2051] = Fluid2D([2946,2925,2920],1); -ELEMENTS[2052] = Fluid2D([2920,2925,2897],1); -ELEMENTS[2053] = Fluid2D([2897,2925,2902],1); -ELEMENTS[2054] = Fluid2D([2925,2951,2929],1); -ELEMENTS[2055] = Fluid2D([2897,2902,2875],1); -ELEMENTS[2056] = Fluid2D([2875,2902,2881],1); -ELEMENTS[2057] = Fluid2D([2897,2875,2870],1); -ELEMENTS[2058] = Fluid2D([2870,2875,2849],1); -ELEMENTS[2059] = Fluid2D([2849,2875,2853],1); -ELEMENTS[2060] = Fluid2D([2853,2875,2881],1); -ELEMENTS[2061] = Fluid2D([2902,2925,2929],1); -ELEMENTS[2062] = Fluid2D([2781,2804,2808],1); -ELEMENTS[2063] = Fluid2D([2687,2710,2714],1); -ELEMENTS[2064] = Fluid2D([2687,2714,2693],1); -ELEMENTS[2065] = Fluid2D([2693,2714,2721],1); -ELEMENTS[2066] = Fluid2D([2687,2693,2664],1); -ELEMENTS[2067] = Fluid2D([2687,2664,2659],1); -ELEMENTS[2068] = Fluid2D([2664,2693,2670],1); -ELEMENTS[2069] = Fluid2D([2670,2693,2700],1); -ELEMENTS[2070] = Fluid2D([2664,2670,2644],1); -ELEMENTS[2071] = Fluid2D([2644,2670,2649],1); -ELEMENTS[2072] = Fluid2D([2649,2670,2678],1); -ELEMENTS[2073] = Fluid2D([2659,2664,2636],1); -ELEMENTS[2074] = Fluid2D([2636,2664,2644],1); -ELEMENTS[2075] = Fluid2D([2636,2644,2616],1); -ELEMENTS[2076] = Fluid2D([2616,2644,2621],1); -ELEMENTS[2077] = Fluid2D([2616,2621,2593],1); -ELEMENTS[2078] = Fluid2D([2593,2621,2597],1); -ELEMENTS[2079] = Fluid2D([2597,2621,2628],1); -ELEMENTS[2080] = Fluid2D([2678,2670,2700],1); -ELEMENTS[2081] = Fluid2D([2628,2621,2649],1); -ELEMENTS[2082] = Fluid2D([2628,2649,2657],1); -ELEMENTS[2083] = Fluid2D([2649,2621,2644],1); -ELEMENTS[2084] = Fluid2D([2657,2649,2678],1); -ELEMENTS[2085] = Fluid2D([2657,2678,2685],1); -ELEMENTS[2086] = Fluid2D([2685,2678,2707],1); -ELEMENTS[2087] = Fluid2D([2685,2707,2712],1); -ELEMENTS[2088] = Fluid2D([2707,2678,2700],1); -ELEMENTS[2089] = Fluid2D([2712,2707,2735],1); -ELEMENTS[2090] = Fluid2D([2712,2735,2740],1); -ELEMENTS[2091] = Fluid2D([2735,2707,2728],1); -ELEMENTS[2092] = Fluid2D([2728,2707,2700],1); -ELEMENTS[2093] = Fluid2D([2693,2721,2700],1); -ELEMENTS[2094] = Fluid2D([2700,2721,2728],1); -ELEMENTS[2095] = Fluid2D([2740,2735,2762],1); -ELEMENTS[2096] = Fluid2D([2740,2762,2767],1); -ELEMENTS[2097] = Fluid2D([2767,2762,2789],1); -ELEMENTS[2098] = Fluid2D([2789,2762,2783],1); -ELEMENTS[2099] = Fluid2D([2783,2762,2755],1); -ELEMENTS[2100] = Fluid2D([2755,2762,2735],1); -ELEMENTS[2101] = Fluid2D([2755,2735,2728],1); -ELEMENTS[2102] = Fluid2D([2657,2685,2663],1); -ELEMENTS[2103] = Fluid2D([2663,2685,2690],1); -ELEMENTS[2104] = Fluid2D([2657,2663,2634],1); -ELEMENTS[2105] = Fluid2D([2634,2663,2639],1); -ELEMENTS[2106] = Fluid2D([2639,2663,2667],1); -ELEMENTS[2107] = Fluid2D([2690,2685,2712],1); -ELEMENTS[2108] = Fluid2D([2690,2712,2717],1); -ELEMENTS[2109] = Fluid2D([2667,2663,2690],1); -ELEMENTS[2110] = Fluid2D([2667,2690,2696],1); -ELEMENTS[2111] = Fluid2D([2696,2690,2717],1); -ELEMENTS[2112] = Fluid2D([2696,2717,2725],1); -ELEMENTS[2113] = Fluid2D([2717,2712,2740],1); -ELEMENTS[2114] = Fluid2D([2717,2740,2746],1); -ELEMENTS[2115] = Fluid2D([2717,2746,2725],1); -ELEMENTS[2116] = Fluid2D([2746,2740,2767],1); -ELEMENTS[2117] = Fluid2D([2667,2696,2677],1); -ELEMENTS[2118] = Fluid2D([2677,2696,2705],1); -ELEMENTS[2119] = Fluid2D([2705,2696,2725],1); -ELEMENTS[2120] = Fluid2D([2677,2705,2684],1); -ELEMENTS[2121] = Fluid2D([2667,2677,2647],1); -ELEMENTS[2122] = Fluid2D([2667,2647,2639],1); -ELEMENTS[2123] = Fluid2D([2647,2677,2655],1); -ELEMENTS[2124] = Fluid2D([2655,2677,2684],1); -ELEMENTS[2125] = Fluid2D([2655,2684,2662],1); -ELEMENTS[2126] = Fluid2D([2647,2655,2626],1); -ELEMENTS[2127] = Fluid2D([2647,2626,2618],1); -ELEMENTS[2128] = Fluid2D([2626,2655,2633],1); -ELEMENTS[2129] = Fluid2D([2633,2655,2662],1); -ELEMENTS[2130] = Fluid2D([2633,2662,2640],1); -ELEMENTS[2131] = Fluid2D([2639,2647,2618],1); -ELEMENTS[2132] = Fluid2D([2639,2618,2611],1); -ELEMENTS[2133] = Fluid2D([2611,2618,2589],1); -ELEMENTS[2134] = Fluid2D([2589,2618,2596],1); -ELEMENTS[2135] = Fluid2D([2596,2618,2626],1); -ELEMENTS[2136] = Fluid2D([2639,2611,2634],1); -ELEMENTS[2137] = Fluid2D([2634,2611,2606],1); -ELEMENTS[2138] = Fluid2D([2596,2626,2605],1); -ELEMENTS[2139] = Fluid2D([2605,2626,2633],1); -ELEMENTS[2140] = Fluid2D([2606,2611,2584],1); -ELEMENTS[2141] = Fluid2D([2606,2584,2576],1); -ELEMENTS[2142] = Fluid2D([2584,2611,2589],1); -ELEMENTS[2143] = Fluid2D([2576,2584,2555],1); -ELEMENTS[2144] = Fluid2D([2555,2584,2561],1); -ELEMENTS[2145] = Fluid2D([2561,2584,2589],1); -ELEMENTS[2146] = Fluid2D([2634,2606,2628],1); -ELEMENTS[2147] = Fluid2D([2628,2606,2597],1); -ELEMENTS[2148] = Fluid2D([2597,2606,2576],1); -ELEMENTS[2149] = Fluid2D([2561,2589,2568],1); -ELEMENTS[2150] = Fluid2D([2568,2589,2596],1); -ELEMENTS[2151] = Fluid2D([2634,2628,2657],1); -ELEMENTS[2152] = Fluid2D([2568,2596,2574],1); -ELEMENTS[2153] = Fluid2D([2574,2596,2605],1); -ELEMENTS[2154] = Fluid2D([2568,2574,2545],1); -ELEMENTS[2155] = Fluid2D([2568,2545,2539],1); -ELEMENTS[2156] = Fluid2D([2545,2574,2554],1); -ELEMENTS[2157] = Fluid2D([2554,2574,2585],1); -ELEMENTS[2158] = Fluid2D([2539,2545,2517],1); -ELEMENTS[2159] = Fluid2D([2517,2545,2525],1); -ELEMENTS[2160] = Fluid2D([2525,2545,2554],1); -ELEMENTS[2161] = Fluid2D([2525,2554,2533],1); -ELEMENTS[2162] = Fluid2D([2533,2554,2562],1); -ELEMENTS[2163] = Fluid2D([2585,2574,2605],1); -ELEMENTS[2164] = Fluid2D([2533,2562,2541],1); -ELEMENTS[2165] = Fluid2D([2541,2562,2569],1); -ELEMENTS[2166] = Fluid2D([2533,2541,2511],1); -ELEMENTS[2167] = Fluid2D([2511,2541,2519],1); -ELEMENTS[2168] = Fluid2D([2519,2541,2548],1); -ELEMENTS[2169] = Fluid2D([2569,2562,2591],1); -ELEMENTS[2170] = Fluid2D([2591,2562,2585],1); -ELEMENTS[2171] = Fluid2D([2585,2562,2554],1); -ELEMENTS[2172] = Fluid2D([2548,2541,2569],1); -ELEMENTS[2173] = Fluid2D([2548,2569,2578],1); -ELEMENTS[2174] = Fluid2D([2633,2640,2613],1); -ELEMENTS[2175] = Fluid2D([2613,2640,2620],1); -ELEMENTS[2176] = Fluid2D([2633,2613,2605],1); -ELEMENTS[2177] = Fluid2D([2605,2613,2585],1); -ELEMENTS[2178] = Fluid2D([2585,2613,2591],1); -ELEMENTS[2179] = Fluid2D([2578,2569,2598],1); -ELEMENTS[2180] = Fluid2D([2598,2569,2591],1); -ELEMENTS[2181] = Fluid2D([2598,2591,2620],1); -ELEMENTS[2182] = Fluid2D([2620,2591,2613],1); -ELEMENTS[2183] = Fluid2D([2548,2578,2557],1); -ELEMENTS[2184] = Fluid2D([2548,2557,2527],1); -ELEMENTS[2185] = Fluid2D([2527,2557,2537],1); -ELEMENTS[2186] = Fluid2D([2548,2527,2519],1); -ELEMENTS[2187] = Fluid2D([2519,2527,2498],1); -ELEMENTS[2188] = Fluid2D([2519,2498,2490],1); -ELEMENTS[2189] = Fluid2D([2498,2527,2507],1); -ELEMENTS[2190] = Fluid2D([2490,2498,2469],1); -ELEMENTS[2191] = Fluid2D([2507,2527,2537],1); -ELEMENTS[2192] = Fluid2D([2469,2498,2475],1); -ELEMENTS[2193] = Fluid2D([2475,2498,2507],1); -ELEMENTS[2194] = Fluid2D([2475,2507,2485],1); -ELEMENTS[2195] = Fluid2D([2485,2507,2515],1); -ELEMENTS[2196] = Fluid2D([2469,2475,2446],1); -ELEMENTS[2197] = Fluid2D([2446,2475,2456],1); -ELEMENTS[2198] = Fluid2D([2456,2475,2485],1); -ELEMENTS[2199] = Fluid2D([2456,2485,2464],1); -ELEMENTS[2200] = Fluid2D([2464,2485,2494],1); -ELEMENTS[2201] = Fluid2D([2519,2490,2511],1); -ELEMENTS[2202] = Fluid2D([2511,2490,2481],1); -ELEMENTS[2203] = Fluid2D([2511,2481,2503],1); -ELEMENTS[2204] = Fluid2D([2503,2481,2473],1); -ELEMENTS[2205] = Fluid2D([2473,2481,2450],1); -ELEMENTS[2206] = Fluid2D([2450,2481,2460],1); -ELEMENTS[2207] = Fluid2D([2460,2481,2490],1); -ELEMENTS[2208] = Fluid2D([2464,2494,2472],1); -ELEMENTS[2209] = Fluid2D([2515,2507,2537],1); -ELEMENTS[2210] = Fluid2D([2464,2472,2442],1); -ELEMENTS[2211] = Fluid2D([2464,2442,2435],1); -ELEMENTS[2212] = Fluid2D([2435,2442,2413],1); -ELEMENTS[2213] = Fluid2D([2413,2442,2422],1); -ELEMENTS[2214] = Fluid2D([2422,2442,2451],1); -ELEMENTS[2215] = Fluid2D([2422,2451,2433],1); -ELEMENTS[2216] = Fluid2D([2442,2472,2451],1); -ELEMENTS[2217] = Fluid2D([2435,2413,2403],1); -ELEMENTS[2218] = Fluid2D([2435,2403,2425],1); -ELEMENTS[2219] = Fluid2D([2425,2403,2395],1); -ELEMENTS[2220] = Fluid2D([2395,2403,2374],1); -ELEMENTS[2221] = Fluid2D([2395,2374,2364],1); -ELEMENTS[2222] = Fluid2D([2374,2403,2382],1); -ELEMENTS[2223] = Fluid2D([2382,2403,2413],1); -ELEMENTS[2224] = Fluid2D([2364,2374,2344],1); -ELEMENTS[2225] = Fluid2D([2364,2344,2334],1); -ELEMENTS[2226] = Fluid2D([2344,2374,2351],1); -ELEMENTS[2227] = Fluid2D([2351,2374,2382],1); -ELEMENTS[2228] = Fluid2D([2334,2344,2314],1); -ELEMENTS[2229] = Fluid2D([2334,2314,2302],1); -ELEMENTS[2230] = Fluid2D([2314,2344,2321],1); -ELEMENTS[2231] = Fluid2D([2321,2344,2351],1); -ELEMENTS[2232] = Fluid2D([2321,2351,2329],1); -ELEMENTS[2233] = Fluid2D([2329,2351,2361],1); -ELEMENTS[2234] = Fluid2D([2361,2351,2382],1); -ELEMENTS[2235] = Fluid2D([2361,2382,2391],1); -ELEMENTS[2236] = Fluid2D([2302,2314,2281],1); -ELEMENTS[2237] = Fluid2D([2281,2314,2291],1); -ELEMENTS[2238] = Fluid2D([2291,2314,2321],1); -ELEMENTS[2239] = Fluid2D([2391,2382,2413],1); -ELEMENTS[2240] = Fluid2D([2391,2413,2422],1); -ELEMENTS[2241] = Fluid2D([2391,2422,2401],1); -ELEMENTS[2242] = Fluid2D([2401,2422,2433],1); -ELEMENTS[2243] = Fluid2D([2401,2433,2411],1); -ELEMENTS[2244] = Fluid2D([2391,2401,2371],1); -ELEMENTS[2245] = Fluid2D([2391,2371,2361],1); -ELEMENTS[2246] = Fluid2D([2371,2401,2379],1); -ELEMENTS[2247] = Fluid2D([2379,2401,2411],1); -ELEMENTS[2248] = Fluid2D([2379,2411,2389],1); -ELEMENTS[2249] = Fluid2D([2379,2389,2359],1); -ELEMENTS[2250] = Fluid2D([2359,2389,2369],1); -ELEMENTS[2251] = Fluid2D([2359,2369,2338],1); -ELEMENTS[2252] = Fluid2D([2338,2369,2349],1); -ELEMENTS[2253] = Fluid2D([2359,2338,2327],1); -ELEMENTS[2254] = Fluid2D([2361,2371,2341],1); -ELEMENTS[2255] = Fluid2D([2341,2371,2350],1); -ELEMENTS[2256] = Fluid2D([2327,2338,2307],1); -ELEMENTS[2257] = Fluid2D([2350,2371,2379],1); -ELEMENTS[2258] = Fluid2D([2307,2338,2318],1); -ELEMENTS[2259] = Fluid2D([2318,2338,2349],1); -ELEMENTS[2260] = Fluid2D([2307,2318,2286],1); -ELEMENTS[2261] = Fluid2D([2307,2286,2276],1); -ELEMENTS[2262] = Fluid2D([2286,2318,2296],1); -ELEMENTS[2263] = Fluid2D([2296,2318,2326],1); -ELEMENTS[2264] = Fluid2D([2276,2286,2253],1); -ELEMENTS[2265] = Fluid2D([2253,2286,2265],1); -ELEMENTS[2266] = Fluid2D([2265,2286,2296],1); -ELEMENTS[2267] = Fluid2D([2318,2349,2326],1); -ELEMENTS[2268] = Fluid2D([2435,2425,2456],1); -ELEMENTS[2269] = Fluid2D([2456,2425,2446],1); -ELEMENTS[2270] = Fluid2D([2435,2456,2464],1); -ELEMENTS[2271] = Fluid2D([2446,2425,2417],1); -ELEMENTS[2272] = Fluid2D([2446,2417,2439],1); -ELEMENTS[2273] = Fluid2D([2439,2417,2409],1); -ELEMENTS[2274] = Fluid2D([2439,2409,2431],1); -ELEMENTS[2275] = Fluid2D([2431,2409,2399],1); -ELEMENTS[2276] = Fluid2D([2409,2417,2387],1); -ELEMENTS[2277] = Fluid2D([2399,2409,2377],1); -ELEMENTS[2278] = Fluid2D([2377,2409,2387],1); -ELEMENTS[2279] = Fluid2D([2387,2417,2395],1); -ELEMENTS[2280] = Fluid2D([2377,2387,2356],1); -ELEMENTS[2281] = Fluid2D([2356,2387,2364],1); -ELEMENTS[2282] = Fluid2D([2417,2425,2395],1); -ELEMENTS[2283] = Fluid2D([2364,2387,2395],1); -ELEMENTS[2284] = Fluid2D([2446,2439,2469],1); -ELEMENTS[2285] = Fluid2D([2469,2439,2460],1); -ELEMENTS[2286] = Fluid2D([2469,2460,2490],1); -ELEMENTS[2287] = Fluid2D([2460,2439,2431],1); -ELEMENTS[2288] = Fluid2D([2460,2431,2450],1); -ELEMENTS[2289] = Fluid2D([2450,2431,2421],1); -ELEMENTS[2290] = Fluid2D([2421,2431,2399],1); -ELEMENTS[2291] = Fluid2D([2450,2421,2444],1); -ELEMENTS[2292] = Fluid2D([2444,2421,2414],1); -ELEMENTS[2293] = Fluid2D([2414,2421,2393],1); -ELEMENTS[2294] = Fluid2D([2393,2421,2399],1); -ELEMENTS[2295] = Fluid2D([2414,2393,2384],1); -ELEMENTS[2296] = Fluid2D([2414,2384,2407],1); -ELEMENTS[2297] = Fluid2D([2384,2393,2362],1); -ELEMENTS[2298] = Fluid2D([2362,2393,2370],1); -ELEMENTS[2299] = Fluid2D([2370,2393,2399],1); -ELEMENTS[2300] = Fluid2D([2370,2399,2377],1); -ELEMENTS[2301] = Fluid2D([2407,2384,2375],1); -ELEMENTS[2302] = Fluid2D([2375,2384,2353],1); -ELEMENTS[2303] = Fluid2D([2375,2353,2345],1); -ELEMENTS[2304] = Fluid2D([2345,2353,2323],1); -ELEMENTS[2305] = Fluid2D([2353,2384,2362],1); -ELEMENTS[2306] = Fluid2D([2323,2353,2332],1); -ELEMENTS[2307] = Fluid2D([2332,2353,2362],1); -ELEMENTS[2308] = Fluid2D([2323,2332,2300],1); -ELEMENTS[2309] = Fluid2D([2323,2300,2292],1); -ELEMENTS[2310] = Fluid2D([2300,2332,2310],1); -ELEMENTS[2311] = Fluid2D([2310,2332,2340],1); -ELEMENTS[2312] = Fluid2D([2292,2300,2270],1); -ELEMENTS[2313] = Fluid2D([2270,2300,2278],1); -ELEMENTS[2314] = Fluid2D([2278,2300,2310],1); -ELEMENTS[2315] = Fluid2D([2340,2332,2362],1); -ELEMENTS[2316] = Fluid2D([2340,2362,2370],1); -ELEMENTS[2317] = Fluid2D([2340,2370,2347],1); -ELEMENTS[2318] = Fluid2D([2340,2347,2316],1); -ELEMENTS[2319] = Fluid2D([2347,2370,2377],1); -ELEMENTS[2320] = Fluid2D([2316,2347,2325],1); -ELEMENTS[2321] = Fluid2D([2325,2347,2356],1); -ELEMENTS[2322] = Fluid2D([2316,2325,2295],1); -ELEMENTS[2323] = Fluid2D([2295,2325,2302],1); -ELEMENTS[2324] = Fluid2D([2347,2377,2356],1); -ELEMENTS[2325] = Fluid2D([2302,2325,2334],1); -ELEMENTS[2326] = Fluid2D([2334,2325,2356],1); -ELEMENTS[2327] = Fluid2D([2334,2356,2364],1); -ELEMENTS[2328] = Fluid2D([2450,2444,2473],1); -ELEMENTS[2329] = Fluid2D([2473,2444,2466],1); -ELEMENTS[2330] = Fluid2D([2466,2444,2437],1); -ELEMENTS[2331] = Fluid2D([2473,2466,2495],1); -ELEMENTS[2332] = Fluid2D([2495,2466,2488],1); -ELEMENTS[2333] = Fluid2D([2488,2466,2458],1); -ELEMENTS[2334] = Fluid2D([2495,2488,2517],1); -ELEMENTS[2335] = Fluid2D([2517,2488,2509],1); -ELEMENTS[2336] = Fluid2D([2509,2488,2480],1); -ELEMENTS[2337] = Fluid2D([2480,2488,2458],1); -ELEMENTS[2338] = Fluid2D([2437,2444,2414],1); -ELEMENTS[2339] = Fluid2D([2437,2414,2407],1); -ELEMENTS[2340] = Fluid2D([2437,2407,2426],1); -ELEMENTS[2341] = Fluid2D([2437,2426,2458],1); -ELEMENTS[2342] = Fluid2D([2458,2426,2449],1); -ELEMENTS[2343] = Fluid2D([2449,2426,2420],1); -ELEMENTS[2344] = Fluid2D([2426,2407,2398],1); -ELEMENTS[2345] = Fluid2D([2398,2407,2375],1); -ELEMENTS[2346] = Fluid2D([2420,2426,2398],1); -ELEMENTS[2347] = Fluid2D([2420,2398,2392],1); -ELEMENTS[2348] = Fluid2D([2392,2398,2368],1); -ELEMENTS[2349] = Fluid2D([2368,2398,2375],1); -ELEMENTS[2350] = Fluid2D([2420,2392,2416],1); -ELEMENTS[2351] = Fluid2D([2458,2466,2437],1); -ELEMENTS[2352] = Fluid2D([2420,2416,2445],1); -ELEMENTS[2353] = Fluid2D([2445,2416,2438],1); -ELEMENTS[2354] = Fluid2D([2438,2416,2408],1); -ELEMENTS[2355] = Fluid2D([2408,2416,2385],1); -ELEMENTS[2356] = Fluid2D([2385,2416,2392],1); -ELEMENTS[2357] = Fluid2D([2438,2408,2432],1); -ELEMENTS[2358] = Fluid2D([2432,2408,2402],1); -ELEMENTS[2359] = Fluid2D([2438,2432,2461],1); -ELEMENTS[2360] = Fluid2D([2402,2408,2378],1); -ELEMENTS[2361] = Fluid2D([2461,2432,2453],1); -ELEMENTS[2362] = Fluid2D([2453,2432,2423],1); -ELEMENTS[2363] = Fluid2D([2378,2408,2385],1); -ELEMENTS[2364] = Fluid2D([2423,2432,2402],1); -ELEMENTS[2365] = Fluid2D([2423,2402,2394],1); -ELEMENTS[2366] = Fluid2D([2394,2402,2373],1); -ELEMENTS[2367] = Fluid2D([2423,2394,2418],1); -ELEMENTS[2368] = Fluid2D([2418,2394,2388],1); -ELEMENTS[2369] = Fluid2D([2373,2402,2378],1); -ELEMENTS[2370] = Fluid2D([2388,2394,2365],1); -ELEMENTS[2371] = Fluid2D([2388,2365,2358],1); -ELEMENTS[2372] = Fluid2D([2365,2394,2373],1); -ELEMENTS[2373] = Fluid2D([2358,2365,2335],1); -ELEMENTS[2374] = Fluid2D([2358,2335,2328],1); -ELEMENTS[2375] = Fluid2D([2335,2365,2342],1); -ELEMENTS[2376] = Fluid2D([2342,2365,2373],1); -ELEMENTS[2377] = Fluid2D([2342,2373,2348],1); -ELEMENTS[2378] = Fluid2D([2348,2373,2378],1); -ELEMENTS[2379] = Fluid2D([2328,2335,2304],1); -ELEMENTS[2380] = Fluid2D([2328,2304,2298],1); -ELEMENTS[2381] = Fluid2D([2304,2335,2312],1); -ELEMENTS[2382] = Fluid2D([2312,2335,2342],1); -ELEMENTS[2383] = Fluid2D([2312,2342,2319],1); -ELEMENTS[2384] = Fluid2D([2319,2342,2348],1); -ELEMENTS[2385] = Fluid2D([2298,2304,2274],1); -ELEMENTS[2386] = Fluid2D([2298,2274,2269],1); -ELEMENTS[2387] = Fluid2D([2274,2304,2282],1); -ELEMENTS[2388] = Fluid2D([2282,2304,2312],1); -ELEMENTS[2389] = Fluid2D([2282,2312,2290],1); -ELEMENTS[2390] = Fluid2D([2290,2312,2319],1); -ELEMENTS[2391] = Fluid2D([2290,2319,2294],1); -ELEMENTS[2392] = Fluid2D([2294,2319,2324],1); -ELEMENTS[2393] = Fluid2D([2269,2274,2244],1); -ELEMENTS[2394] = Fluid2D([2244,2274,2251],1); -ELEMENTS[2395] = Fluid2D([2251,2274,2282],1); -ELEMENTS[2396] = Fluid2D([2324,2319,2348],1); -ELEMENTS[2397] = Fluid2D([2324,2348,2354],1); -ELEMENTS[2398] = Fluid2D([2324,2354,2333],1); -ELEMENTS[2399] = Fluid2D([2333,2354,2363],1); -ELEMENTS[2400] = Fluid2D([2363,2354,2385],1); -ELEMENTS[2401] = Fluid2D([2385,2354,2378],1); -ELEMENTS[2402] = Fluid2D([2378,2354,2348],1); -ELEMENTS[2403] = Fluid2D([2385,2392,2363],1); -ELEMENTS[2404] = Fluid2D([2363,2392,2368],1); -ELEMENTS[2405] = Fluid2D([2363,2368,2339],1); -ELEMENTS[2406] = Fluid2D([2363,2339,2333],1); -ELEMENTS[2407] = Fluid2D([2339,2368,2345],1); -ELEMENTS[2408] = Fluid2D([2345,2368,2375],1); -ELEMENTS[2409] = Fluid2D([2339,2345,2315],1); -ELEMENTS[2410] = Fluid2D([2315,2345,2323],1); -ELEMENTS[2411] = Fluid2D([2315,2323,2292],1); -ELEMENTS[2412] = Fluid2D([2315,2292,2284],1); -ELEMENTS[2413] = Fluid2D([2284,2292,2261],1); -ELEMENTS[2414] = Fluid2D([2261,2292,2270],1); -ELEMENTS[2415] = Fluid2D([2261,2270,2239],1); -ELEMENTS[2416] = Fluid2D([2239,2270,2248],1); -ELEMENTS[2417] = Fluid2D([2248,2270,2278],1); -ELEMENTS[2418] = Fluid2D([2239,2248,2217],1); -ELEMENTS[2419] = Fluid2D([2239,2217,2209],1); -ELEMENTS[2420] = Fluid2D([2217,2248,2224],1); -ELEMENTS[2421] = Fluid2D([2224,2248,2254],1); -ELEMENTS[2422] = Fluid2D([2209,2217,2185],1); -ELEMENTS[2423] = Fluid2D([2185,2217,2193],1); -ELEMENTS[2424] = Fluid2D([2193,2217,2224],1); -ELEMENTS[2425] = Fluid2D([2254,2248,2278],1); -ELEMENTS[2426] = Fluid2D([2254,2278,2285],1); -ELEMENTS[2427] = Fluid2D([2254,2285,2263],1); -ELEMENTS[2428] = Fluid2D([2263,2285,2295],1); -ELEMENTS[2429] = Fluid2D([2295,2285,2316],1); -ELEMENTS[2430] = Fluid2D([2316,2285,2310],1); -ELEMENTS[2431] = Fluid2D([2316,2310,2340],1); -ELEMENTS[2432] = Fluid2D([2285,2278,2310],1); -ELEMENTS[2433] = Fluid2D([2333,2339,2309],1); -ELEMENTS[2434] = Fluid2D([2333,2309,2301],1); -ELEMENTS[2435] = Fluid2D([2301,2309,2279],1); -ELEMENTS[2436] = Fluid2D([2301,2279,2271],1); -ELEMENTS[2437] = Fluid2D([2279,2309,2284],1); -ELEMENTS[2438] = Fluid2D([2271,2279,2249],1); -ELEMENTS[2439] = Fluid2D([2249,2279,2252],1); -ELEMENTS[2440] = Fluid2D([2252,2279,2284],1); -ELEMENTS[2441] = Fluid2D([2252,2284,2261],1); -ELEMENTS[2442] = Fluid2D([2271,2249,2241],1); -ELEMENTS[2443] = Fluid2D([2271,2241,2264],1); -ELEMENTS[2444] = Fluid2D([2241,2249,2218],1); -ELEMENTS[2445] = Fluid2D([2218,2249,2223],1); -ELEMENTS[2446] = Fluid2D([2223,2249,2252],1); -ELEMENTS[2447] = Fluid2D([2264,2241,2233],1); -ELEMENTS[2448] = Fluid2D([2233,2241,2210],1); -ELEMENTS[2449] = Fluid2D([2210,2241,2218],1); -ELEMENTS[2450] = Fluid2D([2223,2252,2231],1); -ELEMENTS[2451] = Fluid2D([2223,2231,2199],1); -ELEMENTS[2452] = Fluid2D([2199,2231,2209],1); -ELEMENTS[2453] = Fluid2D([2231,2252,2261],1); -ELEMENTS[2454] = Fluid2D([2284,2309,2315],1); -ELEMENTS[2455] = Fluid2D([2315,2309,2339],1); -ELEMENTS[2456] = Fluid2D([2209,2231,2239],1); -ELEMENTS[2457] = Fluid2D([2239,2231,2261],1); -ELEMENTS[2458] = Fluid2D([2420,2445,2449],1); -ELEMENTS[2459] = Fluid2D([2449,2445,2474],1); -ELEMENTS[2460] = Fluid2D([2449,2474,2480],1); -ELEMENTS[2461] = Fluid2D([2480,2474,2502],1); -ELEMENTS[2462] = Fluid2D([2502,2474,2497],1); -ELEMENTS[2463] = Fluid2D([2502,2497,2526],1); -ELEMENTS[2464] = Fluid2D([2497,2474,2467],1); -ELEMENTS[2465] = Fluid2D([2474,2445,2467],1); -ELEMENTS[2466] = Fluid2D([2526,2497,2518],1); -ELEMENTS[2467] = Fluid2D([2518,2497,2489],1); -ELEMENTS[2468] = Fluid2D([2526,2518,2546],1); -ELEMENTS[2469] = Fluid2D([2546,2518,2542],1); -ELEMENTS[2470] = Fluid2D([2542,2518,2513],1); -ELEMENTS[2471] = Fluid2D([2489,2497,2467],1); -ELEMENTS[2472] = Fluid2D([2513,2518,2489],1); -ELEMENTS[2473] = Fluid2D([2513,2489,2484],1); -ELEMENTS[2474] = Fluid2D([2484,2489,2461],1); -ELEMENTS[2475] = Fluid2D([2467,2445,2438],1); -ELEMENTS[2476] = Fluid2D([2461,2489,2467],1); -ELEMENTS[2477] = Fluid2D([2461,2467,2438],1); -ELEMENTS[2478] = Fluid2D([2484,2461,2453],1); -ELEMENTS[2479] = Fluid2D([2484,2453,2476],1); -ELEMENTS[2480] = Fluid2D([2476,2453,2447],1); -ELEMENTS[2481] = Fluid2D([2447,2453,2423],1); -ELEMENTS[2482] = Fluid2D([2447,2423,2418],1); -ELEMENTS[2483] = Fluid2D([2447,2418,2441],1); -ELEMENTS[2484] = Fluid2D([2476,2447,2470],1); -ELEMENTS[2485] = Fluid2D([2470,2447,2441],1); -ELEMENTS[2486] = Fluid2D([2441,2418,2412],1); -ELEMENTS[2487] = Fluid2D([2412,2418,2388],1); -ELEMENTS[2488] = Fluid2D([2412,2388,2383],1); -ELEMENTS[2489] = Fluid2D([2383,2388,2358],1); -ELEMENTS[2490] = Fluid2D([2412,2383,2406],1); -ELEMENTS[2491] = Fluid2D([2406,2383,2376],1); -ELEMENTS[2492] = Fluid2D([2412,2406,2436],1); -ELEMENTS[2493] = Fluid2D([2436,2406,2430],1); -ELEMENTS[2494] = Fluid2D([2430,2406,2400],1); -ELEMENTS[2495] = Fluid2D([2376,2383,2352],1); -ELEMENTS[2496] = Fluid2D([2352,2383,2358],1); -ELEMENTS[2497] = Fluid2D([2352,2358,2328],1); -ELEMENTS[2498] = Fluid2D([2352,2328,2322],1); -ELEMENTS[2499] = Fluid2D([2322,2328,2298],1); -ELEMENTS[2500] = Fluid2D([2400,2406,2376],1); -ELEMENTS[2501] = Fluid2D([2400,2376,2372],1); -ELEMENTS[2502] = Fluid2D([2372,2376,2346],1); -ELEMENTS[2503] = Fluid2D([2372,2346,2343],1); -ELEMENTS[2504] = Fluid2D([2346,2376,2352],1); -ELEMENTS[2505] = Fluid2D([2346,2352,2322],1); -ELEMENTS[2506] = Fluid2D([2346,2322,2317],1); -ELEMENTS[2507] = Fluid2D([2317,2322,2293],1); -ELEMENTS[2508] = Fluid2D([2293,2322,2298],1); -ELEMENTS[2509] = Fluid2D([2343,2346,2317],1); -ELEMENTS[2510] = Fluid2D([2343,2317,2313],1); -ELEMENTS[2511] = Fluid2D([2313,2317,2289],1); -ELEMENTS[2512] = Fluid2D([2289,2317,2293],1); -ELEMENTS[2513] = Fluid2D([2289,2293,2262],1); -ELEMENTS[2514] = Fluid2D([2262,2293,2269],1); -ELEMENTS[2515] = Fluid2D([2269,2293,2298],1); -ELEMENTS[2516] = Fluid2D([2343,2313,2337],1); -ELEMENTS[2517] = Fluid2D([2337,2313,2306],1); -ELEMENTS[2518] = Fluid2D([2343,2337,2366],1); -ELEMENTS[2519] = Fluid2D([2306,2313,2283],1); -ELEMENTS[2520] = Fluid2D([2283,2313,2289],1); -ELEMENTS[2521] = Fluid2D([2366,2337,2360],1); -ELEMENTS[2522] = Fluid2D([2360,2337,2331],1); -ELEMENTS[2523] = Fluid2D([2366,2360,2390],1); -ELEMENTS[2524] = Fluid2D([2390,2360,2386],1); -ELEMENTS[2525] = Fluid2D([2386,2360,2357],1); -ELEMENTS[2526] = Fluid2D([2331,2337,2306],1); -ELEMENTS[2527] = Fluid2D([2357,2360,2331],1); -ELEMENTS[2528] = Fluid2D([2357,2331,2330],1); -ELEMENTS[2529] = Fluid2D([2441,2412,2436],1); -ELEMENTS[2530] = Fluid2D([2441,2436,2465],1); -ELEMENTS[2531] = Fluid2D([2441,2465,2470],1); -ELEMENTS[2532] = Fluid2D([2465,2436,2459],1); -ELEMENTS[2533] = Fluid2D([2459,2436,2430],1); -ELEMENTS[2534] = Fluid2D([2459,2430,2452],1); -ELEMENTS[2535] = Fluid2D([2452,2430,2424],1); -ELEMENTS[2536] = Fluid2D([2452,2424,2448],1); -ELEMENTS[2537] = Fluid2D([2470,2465,2493],1); -ELEMENTS[2538] = Fluid2D([2493,2465,2487],1); -ELEMENTS[2539] = Fluid2D([2487,2465,2459],1); -ELEMENTS[2540] = Fluid2D([2448,2424,2419],1); -ELEMENTS[2541] = Fluid2D([2448,2419,2443],1); -ELEMENTS[2542] = Fluid2D([2448,2443,2471],1); -ELEMENTS[2543] = Fluid2D([2443,2419,2415],1); -ELEMENTS[2544] = Fluid2D([2415,2419,2390],1); -ELEMENTS[2545] = Fluid2D([2390,2419,2396],1); -ELEMENTS[2546] = Fluid2D([2396,2419,2424],1); -ELEMENTS[2547] = Fluid2D([2471,2443,2468],1); -ELEMENTS[2548] = Fluid2D([2468,2443,2440],1); -ELEMENTS[2549] = Fluid2D([2440,2443,2415],1); -ELEMENTS[2550] = Fluid2D([2471,2468,2496],1); -ELEMENTS[2551] = Fluid2D([2496,2468,2491],1); -ELEMENTS[2552] = Fluid2D([2491,2468,2463],1); -ELEMENTS[2553] = Fluid2D([2463,2468,2440],1); -ELEMENTS[2554] = Fluid2D([2440,2415,2410],1); -ELEMENTS[2555] = Fluid2D([2410,2415,2386],1); -ELEMENTS[2556] = Fluid2D([2386,2415,2390],1); -ELEMENTS[2557] = Fluid2D([2440,2410,2434],1); -ELEMENTS[2558] = Fluid2D([2440,2434,2463],1); -ELEMENTS[2559] = Fluid2D([2434,2410,2404],1); -ELEMENTS[2560] = Fluid2D([2404,2410,2381],1); -ELEMENTS[2561] = Fluid2D([2381,2410,2386],1); -ELEMENTS[2562] = Fluid2D([2381,2386,2357],1); -ELEMENTS[2563] = Fluid2D([2381,2357,2330],1); -ELEMENTS[2564] = Fluid2D([2463,2434,2457],1); -ELEMENTS[2565] = Fluid2D([2457,2434,2427],1); -ELEMENTS[2566] = Fluid2D([2427,2434,2404],1); -ELEMENTS[2567] = Fluid2D([2463,2457,2486],1); -ELEMENTS[2568] = Fluid2D([2486,2457,2482],1); -ELEMENTS[2569] = Fluid2D([2482,2457,2454],1); -ELEMENTS[2570] = Fluid2D([2454,2457,2427],1); -ELEMENTS[2571] = Fluid2D([2454,2427,2405],1); -ELEMENTS[2572] = Fluid2D([2427,2404,2380],1); -ELEMENTS[2573] = Fluid2D([2396,2424,2400],1); -ELEMENTS[2574] = Fluid2D([2400,2424,2430],1); -ELEMENTS[2575] = Fluid2D([2396,2400,2372],1); -ELEMENTS[2576] = Fluid2D([2396,2372,2366],1); -ELEMENTS[2577] = Fluid2D([2366,2372,2343],1); -ELEMENTS[2578] = Fluid2D([2449,2480,2458],1); -ELEMENTS[2579] = Fluid2D([2494,2485,2515],1); -ELEMENTS[2580] = Fluid2D([3181,3204,3205],1); -ELEMENTS[2581] = Fluid2D([3205,3204,3229],1); -ELEMENTS[2582] = Fluid2D([3205,3229,3230],1); -ELEMENTS[2583] = Fluid2D([3230,3229,3252],1); -ELEMENTS[2584] = Fluid2D([3230,3252,3254],1); -ELEMENTS[2585] = Fluid2D([3254,3252,3276],1); -ELEMENTS[2586] = Fluid2D([3254,3276,3278],1); -ELEMENTS[2587] = Fluid2D([3278,3276,3301],1); -ELEMENTS[2588] = Fluid2D([3181,3205,3179],1); -ELEMENTS[2589] = Fluid2D([3252,3229,3250],1); -ELEMENTS[2590] = Fluid2D([3301,3276,3300],1); -ELEMENTS[2591] = Fluid2D([3179,3205,3201],1); -ELEMENTS[2592] = Fluid2D([3201,3205,3230],1); -ELEMENTS[2593] = Fluid2D([3201,3230,3225],1); -ELEMENTS[2594] = Fluid2D([3225,3230,3254],1); -ELEMENTS[2595] = Fluid2D([3225,3254,3251],1); -ELEMENTS[2596] = Fluid2D([3251,3254,3278],1); -ELEMENTS[2597] = Fluid2D([3251,3278,3284],1); -ELEMENTS[2598] = Fluid2D([3284,3278,3309],1); -ELEMENTS[2599] = Fluid2D([3309,3278,3301],1); -ELEMENTS[2600] = Fluid2D([3250,3229,3227],1); -ELEMENTS[2601] = Fluid2D([3250,3227,3249],1); -ELEMENTS[2602] = Fluid2D([3300,3276,3275],1); -ELEMENTS[2603] = Fluid2D([3275,3276,3252],1); -ELEMENTS[2604] = Fluid2D([3300,3275,3298],1); -ELEMENTS[2605] = Fluid2D([3298,3275,3274],1); -ELEMENTS[2606] = Fluid2D([3300,3298,3329],1); -ELEMENTS[2607] = Fluid2D([3329,3298,3320],1); -ELEMENTS[2608] = Fluid2D([3320,3298,3296],1); -ELEMENTS[2609] = Fluid2D([3296,3298,3274],1); -ELEMENTS[2610] = Fluid2D([3274,3275,3250],1); -ELEMENTS[2611] = Fluid2D([3274,3250,3249],1); -ELEMENTS[2612] = Fluid2D([3250,3275,3252],1); -ELEMENTS[2613] = Fluid2D([3227,3229,3204],1); -ELEMENTS[2614] = Fluid2D([2727,2697,2720],1); -ELEMENTS[2615] = Fluid2D([2720,2697,2692],1); -ELEMENTS[2616] = Fluid2D([2692,2697,2669],1); -ELEMENTS[2617] = Fluid2D([2692,2669,2665],1); -ELEMENTS[2618] = Fluid2D([2665,2669,2643],1); -ELEMENTS[2619] = Fluid2D([2665,2643,2637],1); -ELEMENTS[2620] = Fluid2D([2727,2720,2749],1); -ELEMENTS[2621] = Fluid2D([2749,2720,2742],1); -ELEMENTS[2622] = Fluid2D([2742,2720,2715],1); -ELEMENTS[2623] = Fluid2D([2720,2692,2715],1); -ELEMENTS[2624] = Fluid2D([2715,2692,2688],1); -ELEMENTS[2625] = Fluid2D([2637,2643,2614],1); -ELEMENTS[2626] = Fluid2D([2742,2715,2738],1); -ELEMENTS[2627] = Fluid2D([2738,2715,2711],1); -ELEMENTS[2628] = Fluid2D([2742,2738,2765],1); -ELEMENTS[2629] = Fluid2D([2742,2765,2770],1); -ELEMENTS[2630] = Fluid2D([2770,2765,2793],1); -ELEMENTS[2631] = Fluid2D([2793,2765,2787],1); -ELEMENTS[2632] = Fluid2D([2787,2765,2761],1); -ELEMENTS[2633] = Fluid2D([2761,2765,2738],1); -ELEMENTS[2634] = Fluid2D([2688,2692,2665],1); -ELEMENTS[2635] = Fluid2D([2688,2665,2660],1); -ELEMENTS[2636] = Fluid2D([2711,2715,2688],1); -ELEMENTS[2637] = Fluid2D([2711,2688,2683],1); -ELEMENTS[2638] = Fluid2D([2660,2665,2637],1); -ELEMENTS[2639] = Fluid2D([2660,2637,2632],1); -ELEMENTS[2640] = Fluid2D([2683,2688,2660],1); -ELEMENTS[2641] = Fluid2D([2683,2660,2656],1); -ELEMENTS[2642] = Fluid2D([2632,2637,2609],1); -ELEMENTS[2643] = Fluid2D([2632,2609,2604],1); -ELEMENTS[2644] = Fluid2D([2609,2637,2614],1); -ELEMENTS[2645] = Fluid2D([2609,2614,2587],1); -ELEMENTS[2646] = Fluid2D([2609,2587,2581],1); -ELEMENTS[2647] = Fluid2D([2656,2660,2632],1); -ELEMENTS[2648] = Fluid2D([2581,2587,2559],1); -ELEMENTS[2649] = Fluid2D([2581,2559,2553],1); -ELEMENTS[2650] = Fluid2D([2553,2559,2530],1); -ELEMENTS[2651] = Fluid2D([2553,2530,2524],1); -ELEMENTS[2652] = Fluid2D([2581,2553,2575],1); -ELEMENTS[2653] = Fluid2D([2575,2553,2547],1); -ELEMENTS[2654] = Fluid2D([2524,2530,2500],1); -ELEMENTS[2655] = Fluid2D([2524,2500,2496],1); -ELEMENTS[2656] = Fluid2D([2547,2553,2524],1); -ELEMENTS[2657] = Fluid2D([2547,2524,2520],1); -ELEMENTS[2658] = Fluid2D([2520,2524,2496],1); -ELEMENTS[2659] = Fluid2D([2520,2496,2491],1); -ELEMENTS[2660] = Fluid2D([2604,2609,2581],1); -ELEMENTS[2661] = Fluid2D([2604,2581,2575],1); -ELEMENTS[2662] = Fluid2D([2604,2575,2599],1); -ELEMENTS[2663] = Fluid2D([2599,2575,2571],1); -ELEMENTS[2664] = Fluid2D([2604,2599,2629],1); -ELEMENTS[2665] = Fluid2D([2629,2599,2622],1); -ELEMENTS[2666] = Fluid2D([2622,2599,2594],1); -ELEMENTS[2667] = Fluid2D([2594,2599,2571],1); -ELEMENTS[2668] = Fluid2D([2571,2575,2547],1); -ELEMENTS[2669] = Fluid2D([2571,2547,2543],1); -ELEMENTS[2670] = Fluid2D([2543,2547,2520],1); -ELEMENTS[2671] = Fluid2D([2543,2520,2514],1); -ELEMENTS[2672] = Fluid2D([2514,2520,2491],1); -ELEMENTS[2673] = Fluid2D([2514,2491,2486],1); -ELEMENTS[2674] = Fluid2D([2486,2491,2463],1); -ELEMENTS[2675] = Fluid2D([2496,2500,2471],1); -ELEMENTS[2676] = Fluid2D([2761,2738,2734],1); -ELEMENTS[2677] = Fluid2D([2761,2734,2757],1); -ELEMENTS[2678] = Fluid2D([2757,2734,2729],1); -ELEMENTS[2679] = Fluid2D([2729,2734,2708],1); -ELEMENTS[2680] = Fluid2D([2708,2734,2711],1); -ELEMENTS[2681] = Fluid2D([2711,2734,2738],1); -ELEMENTS[2682] = Fluid2D([2757,2729,2752],1); -ELEMENTS[2683] = Fluid2D([2752,2729,2724],1); -ELEMENTS[2684] = Fluid2D([2724,2729,2701],1); -ELEMENTS[2685] = Fluid2D([2724,2701,2695],1); -ELEMENTS[2686] = Fluid2D([2701,2729,2708],1); -ELEMENTS[2687] = Fluid2D([2757,2752,2779],1); -ELEMENTS[2688] = Fluid2D([2701,2708,2680],1); -ELEMENTS[2689] = Fluid2D([2680,2708,2683],1); -ELEMENTS[2690] = Fluid2D([2683,2708,2711],1); -ELEMENTS[2691] = Fluid2D([2779,2752,2775],1); -ELEMENTS[2692] = Fluid2D([2775,2752,2748],1); -ELEMENTS[2693] = Fluid2D([2695,2701,2673],1); -ELEMENTS[2694] = Fluid2D([2695,2673,2668],1); -ELEMENTS[2695] = Fluid2D([2673,2701,2680],1); -ELEMENTS[2696] = Fluid2D([2673,2680,2651],1); -ELEMENTS[2697] = Fluid2D([2651,2680,2656],1); -ELEMENTS[2698] = Fluid2D([2656,2680,2683],1); -ELEMENTS[2699] = Fluid2D([2748,2752,2724],1); -ELEMENTS[2700] = Fluid2D([2668,2673,2646],1); -ELEMENTS[2701] = Fluid2D([2668,2646,2641],1); -ELEMENTS[2702] = Fluid2D([2646,2673,2651],1); -ELEMENTS[2703] = Fluid2D([2646,2651,2622],1); -ELEMENTS[2704] = Fluid2D([2646,2622,2617],1); -ELEMENTS[2705] = Fluid2D([2641,2646,2617],1); -ELEMENTS[2706] = Fluid2D([2641,2617,2615],1); -ELEMENTS[2707] = Fluid2D([2615,2617,2590],1); -ELEMENTS[2708] = Fluid2D([2617,2622,2594],1); -ELEMENTS[2709] = Fluid2D([2590,2617,2594],1); -ELEMENTS[2710] = Fluid2D([2590,2594,2566],1); -ELEMENTS[2711] = Fluid2D([2590,2566,2563],1); -ELEMENTS[2712] = Fluid2D([2566,2594,2571],1); -ELEMENTS[2713] = Fluid2D([2563,2566,2538],1); -ELEMENTS[2714] = Fluid2D([2563,2538,2535],1); -ELEMENTS[2715] = Fluid2D([2538,2566,2543],1); -ELEMENTS[2716] = Fluid2D([2543,2566,2571],1); -ELEMENTS[2717] = Fluid2D([2535,2538,2510],1); -ELEMENTS[2718] = Fluid2D([2510,2538,2514],1); -ELEMENTS[2719] = Fluid2D([2510,2514,2486],1); -ELEMENTS[2720] = Fluid2D([2514,2538,2543],1); -ELEMENTS[2721] = Fluid2D([2622,2651,2629],1); -ELEMENTS[2722] = Fluid2D([2629,2651,2656],1); -ELEMENTS[2723] = Fluid2D([2779,2775,2802],1); -ELEMENTS[2724] = Fluid2D([2802,2775,2798],1); -ELEMENTS[2725] = Fluid2D([2798,2775,2769],1); -ELEMENTS[2726] = Fluid2D([2802,2798,2825],1); -ELEMENTS[2727] = Fluid2D([2825,2798,2822],1); -ELEMENTS[2728] = Fluid2D([2822,2798,2794],1); -ELEMENTS[2729] = Fluid2D([2769,2775,2748],1); -ELEMENTS[2730] = Fluid2D([2769,2748,2743],1); -ELEMENTS[2731] = Fluid2D([2743,2748,2718],1); -ELEMENTS[2732] = Fluid2D([2718,2748,2724],1); -ELEMENTS[2733] = Fluid2D([2718,2724,2695],1); -ELEMENTS[2734] = Fluid2D([2822,2794,2816],1); -ELEMENTS[2735] = Fluid2D([2816,2794,2790],1); -ELEMENTS[2736] = Fluid2D([2822,2816,2843],1); -ELEMENTS[2737] = Fluid2D([2843,2816,2838],1); -ELEMENTS[2738] = Fluid2D([2838,2816,2812],1); -ELEMENTS[2739] = Fluid2D([2790,2794,2766],1); -ELEMENTS[2740] = Fluid2D([2766,2794,2769],1); -ELEMENTS[2741] = Fluid2D([2769,2794,2798],1); -ELEMENTS[2742] = Fluid2D([2812,2816,2790],1); -ELEMENTS[2743] = Fluid2D([2812,2790,2785],1); -ELEMENTS[2744] = Fluid2D([2785,2790,2763],1); -ELEMENTS[2745] = Fluid2D([2785,2763,2759],1); -ELEMENTS[2746] = Fluid2D([2763,2790,2766],1); -ELEMENTS[2747] = Fluid2D([2763,2766,2739],1); -ELEMENTS[2748] = Fluid2D([2739,2766,2743],1); -ELEMENTS[2749] = Fluid2D([2743,2766,2769],1); -ELEMENTS[2750] = Fluid2D([2739,2743,2716],1); -ELEMENTS[2751] = Fluid2D([2716,2743,2718],1); -ELEMENTS[2752] = Fluid2D([2716,2718,2691],1); -ELEMENTS[2753] = Fluid2D([2716,2691,2689],1); -ELEMENTS[2754] = Fluid2D([2691,2718,2695],1); -ELEMENTS[2755] = Fluid2D([2691,2695,2668],1); -ELEMENTS[2756] = Fluid2D([2689,2691,2666],1); -ELEMENTS[2757] = Fluid2D([2689,2666,2661],1); -ELEMENTS[2758] = Fluid2D([2666,2691,2668],1); -ELEMENTS[2759] = Fluid2D([2759,2763,2736],1); -ELEMENTS[2760] = Fluid2D([2759,2736,2733],1); -ELEMENTS[2761] = Fluid2D([2736,2763,2739],1); -ELEMENTS[2762] = Fluid2D([2661,2666,2638],1); -ELEMENTS[2763] = Fluid2D([2661,2638,2635],1); -ELEMENTS[2764] = Fluid2D([2638,2666,2641],1); -ELEMENTS[2765] = Fluid2D([2641,2666,2668],1); -ELEMENTS[2766] = Fluid2D([2733,2736,2709],1); -ELEMENTS[2767] = Fluid2D([2709,2736,2713],1); -ELEMENTS[2768] = Fluid2D([2713,2736,2739],1); -ELEMENTS[2769] = Fluid2D([2635,2638,2610],1); -ELEMENTS[2770] = Fluid2D([2610,2638,2615],1); -ELEMENTS[2771] = Fluid2D([2610,2615,2588],1); -ELEMENTS[2772] = Fluid2D([2615,2638,2641],1); -ELEMENTS[2773] = Fluid2D([2588,2615,2590],1); -ELEMENTS[2774] = Fluid2D([2713,2739,2716],1); -ELEMENTS[2775] = Fluid2D([2713,2716,2689],1); -ELEMENTS[2776] = Fluid2D([2713,2689,2686],1); -ELEMENTS[2777] = Fluid2D([2713,2686,2709],1); -ELEMENTS[2778] = Fluid2D([2709,2686,2682],1); -ELEMENTS[2779] = Fluid2D([2686,2689,2661],1); -ELEMENTS[2780] = Fluid2D([2682,2686,2658],1); -ELEMENTS[2781] = Fluid2D([2682,2658,2654],1); -ELEMENTS[2782] = Fluid2D([2658,2686,2661],1); -ELEMENTS[2783] = Fluid2D([2658,2661,2635],1); -ELEMENTS[2784] = Fluid2D([2654,2658,2630],1); -ELEMENTS[2785] = Fluid2D([2654,2630,2627],1); -ELEMENTS[2786] = Fluid2D([2630,2658,2635],1); -ELEMENTS[2787] = Fluid2D([2630,2635,2607],1); -ELEMENTS[2788] = Fluid2D([2607,2635,2610],1); -ELEMENTS[2789] = Fluid2D([2627,2630,2603],1); -ELEMENTS[2790] = Fluid2D([2603,2630,2607],1); -ELEMENTS[2791] = Fluid2D([2603,2607,2579],1); -ELEMENTS[2792] = Fluid2D([2579,2607,2583],1); -ELEMENTS[2793] = Fluid2D([2583,2607,2610],1); -ELEMENTS[2794] = Fluid2D([2583,2610,2588],1); -ELEMENTS[2795] = Fluid2D([2583,2588,2560],1); -ELEMENTS[2796] = Fluid2D([2560,2588,2563],1); -ELEMENTS[2797] = Fluid2D([2563,2588,2590],1); -ELEMENTS[2798] = Fluid2D([2560,2563,2535],1); -ELEMENTS[2799] = Fluid2D([2560,2535,2531],1); -ELEMENTS[2800] = Fluid2D([2560,2531,2556],1); -ELEMENTS[2801] = Fluid2D([2531,2535,2508],1); -ELEMENTS[2802] = Fluid2D([2508,2535,2510],1); -ELEMENTS[2803] = Fluid2D([2508,2510,2482],1); -ELEMENTS[2804] = Fluid2D([2560,2556,2583],1); -ELEMENTS[2805] = Fluid2D([2583,2556,2579],1); -ELEMENTS[2806] = Fluid2D([2579,2556,2549],1); -ELEMENTS[2807] = Fluid2D([2549,2556,2521],1); -ELEMENTS[2808] = Fluid2D([2521,2556,2531],1); -ELEMENTS[2809] = Fluid2D([2521,2531,2501],1); -ELEMENTS[2810] = Fluid2D([2521,2501,2479],1); -ELEMENTS[2811] = Fluid2D([2501,2531,2508],1); -ELEMENTS[2812] = Fluid2D([2501,2508,2478],1); -ELEMENTS[2813] = Fluid2D([2501,2478,2455],1); -ELEMENTS[2814] = Fluid2D([2478,2508,2482],1); -ELEMENTS[2815] = Fluid2D([2478,2482,2454],1); -ELEMENTS[2816] = Fluid2D([2478,2429,2455],1); -ELEMENTS[2817] = Fluid2D([2482,2510,2486],1); -ELEMENTS[2818] = Fluid2D([2802,2825,2829],1); -ELEMENTS[2819] = Fluid2D([2802,2829,2806],1); -ELEMENTS[2820] = Fluid2D([2806,2829,2834],1); -ELEMENTS[2821] = Fluid2D([2834,2829,2856],1); -ELEMENTS[2822] = Fluid2D([2856,2829,2852],1); -ELEMENTS[2823] = Fluid2D([2852,2829,2825],1); -ELEMENTS[2824] = Fluid2D([2806,2834,2810],1); -ELEMENTS[2825] = Fluid2D([2810,2834,2837],1); -ELEMENTS[2826] = Fluid2D([2837,2834,2860],1); -ELEMENTS[2827] = Fluid2D([2860,2834,2856],1); -ELEMENTS[2828] = Fluid2D([2806,2810,2784],1); -ELEMENTS[2829] = Fluid2D([2806,2784,2779],1); -ELEMENTS[2830] = Fluid2D([2784,2810,2787],1); -ELEMENTS[2831] = Fluid2D([2787,2810,2814],1); -ELEMENTS[2832] = Fluid2D([2779,2784,2757],1); -ELEMENTS[2833] = Fluid2D([2814,2810,2837],1); -ELEMENTS[2834] = Fluid2D([2757,2784,2761],1); -ELEMENTS[2835] = Fluid2D([2761,2784,2787],1); -ELEMENTS[2836] = Fluid2D([2852,2825,2846],1); -ELEMENTS[2837] = Fluid2D([2846,2825,2822],1); -ELEMENTS[2838] = Fluid2D([2852,2846,2874],1); -ELEMENTS[2839] = Fluid2D([2874,2846,2871],1); -ELEMENTS[2840] = Fluid2D([2871,2846,2843],1); -ELEMENTS[2841] = Fluid2D([2874,2871,2898],1); -ELEMENTS[2842] = Fluid2D([2898,2871,2894],1); -ELEMENTS[2843] = Fluid2D([2894,2871,2865],1); -ELEMENTS[2844] = Fluid2D([2865,2871,2843],1); -ELEMENTS[2845] = Fluid2D([2865,2843,2838],1); -ELEMENTS[2846] = Fluid2D([2846,2822,2843],1); -ELEMENTS[2847] = Fluid2D([2865,2838,2861],1); -ELEMENTS[2848] = Fluid2D([2861,2838,2835],1); -ELEMENTS[2849] = Fluid2D([2861,2835,2859],1); -ELEMENTS[2850] = Fluid2D([2859,2835,2833],1); -ELEMENTS[2851] = Fluid2D([2833,2835,2809],1); -ELEMENTS[2852] = Fluid2D([2809,2835,2812],1); -ELEMENTS[2853] = Fluid2D([2865,2861,2888],1); -ELEMENTS[2854] = Fluid2D([2888,2861,2886],1); -ELEMENTS[2855] = Fluid2D([2886,2861,2859],1); -ELEMENTS[2856] = Fluid2D([2886,2859,2882],1); -ELEMENTS[2857] = Fluid2D([2882,2859,2857],1); -ELEMENTS[2858] = Fluid2D([2857,2859,2833],1); -ELEMENTS[2859] = Fluid2D([2857,2833,2830],1); -ELEMENTS[2860] = Fluid2D([2830,2833,2807],1); -ELEMENTS[2861] = Fluid2D([2807,2833,2809],1); -ELEMENTS[2862] = Fluid2D([2835,2838,2812],1); -ELEMENTS[2863] = Fluid2D([2852,2874,2879],1); -ELEMENTS[2864] = Fluid2D([2879,2874,2901],1); -ELEMENTS[2865] = Fluid2D([2901,2874,2898],1); -ELEMENTS[2866] = Fluid2D([2901,2898,2924],1); -ELEMENTS[2867] = Fluid2D([2924,2898,2921],1); -ELEMENTS[2868] = Fluid2D([2921,2898,2894],1); -ELEMENTS[2869] = Fluid2D([2852,2879,2856],1); -ELEMENTS[2870] = Fluid2D([2856,2879,2883],1); -ELEMENTS[2871] = Fluid2D([2921,2894,2915],1); -ELEMENTS[2872] = Fluid2D([2915,2894,2888],1); -ELEMENTS[2873] = Fluid2D([2883,2879,2904],1); -ELEMENTS[2874] = Fluid2D([2904,2879,2901],1); -ELEMENTS[2875] = Fluid2D([2888,2894,2865],1); -ELEMENTS[2876] = Fluid2D([2856,2883,2860],1); -ELEMENTS[2877] = Fluid2D([2860,2883,2887],1); -ELEMENTS[2878] = Fluid2D([2887,2883,2909],1); -ELEMENTS[2879] = Fluid2D([2909,2883,2904],1); -ELEMENTS[2880] = Fluid2D([2860,2887,2864],1); -ELEMENTS[2881] = Fluid2D([2864,2887,2891],1); -ELEMENTS[2882] = Fluid2D([2860,2864,2837],1); -ELEMENTS[2883] = Fluid2D([2891,2887,2913],1); -ELEMENTS[2884] = Fluid2D([2837,2864,2841],1); -ELEMENTS[2885] = Fluid2D([2841,2864,2870],1); -ELEMENTS[2886] = Fluid2D([2870,2864,2891],1); -ELEMENTS[2887] = Fluid2D([2870,2891,2897],1); -ELEMENTS[2888] = Fluid2D([2897,2891,2920],1); -ELEMENTS[2889] = Fluid2D([2837,2841,2814],1); -ELEMENTS[2890] = Fluid2D([2814,2841,2821],1); -ELEMENTS[2891] = Fluid2D([2821,2841,2849],1); -ELEMENTS[2892] = Fluid2D([2849,2841,2870],1); -ELEMENTS[2893] = Fluid2D([2814,2821,2793],1); -ELEMENTS[2894] = Fluid2D([2814,2793,2787],1); -ELEMENTS[2895] = Fluid2D([2913,2887,2909],1); -ELEMENTS[2896] = Fluid2D([2913,2909,2935],1); -ELEMENTS[2897] = Fluid2D([2935,2909,2930],1); -ELEMENTS[2898] = Fluid2D([2793,2821,2799],1); -ELEMENTS[2899] = Fluid2D([2799,2821,2826],1); -ELEMENTS[2900] = Fluid2D([2826,2821,2849],1); -ELEMENTS[2901] = Fluid2D([2793,2799,2770],1); -ELEMENTS[2902] = Fluid2D([2930,2909,2904],1); -ELEMENTS[2903] = Fluid2D([2930,2904,2927],1); -ELEMENTS[2904] = Fluid2D([2927,2904,2901],1); -ELEMENTS[2905] = Fluid2D([2927,2901,2924],1); -ELEMENTS[2906] = Fluid2D([2927,2924,2950],1); -ELEMENTS[2907] = Fluid2D([2930,2927,2953],1); -ELEMENTS[2908] = Fluid2D([2930,2953,2957],1); -ELEMENTS[2909] = Fluid2D([2950,2924,2947],1); -ELEMENTS[2910] = Fluid2D([2947,2924,2921],1); -ELEMENTS[2911] = Fluid2D([2947,2921,2944],1); -ELEMENTS[2912] = Fluid2D([2944,2921,2915],1); -ELEMENTS[2913] = Fluid2D([2953,2927,2950],1); -ELEMENTS[2914] = Fluid2D([2953,2950,2976],1); -ELEMENTS[2915] = Fluid2D([2976,2950,2972],1); -ELEMENTS[2916] = Fluid2D([2972,2950,2947],1); -ELEMENTS[2917] = Fluid2D([2972,2947,2970],1); -ELEMENTS[2918] = Fluid2D([2970,2947,2944],1); -ELEMENTS[2919] = Fluid2D([2972,2970,2996],1); -ELEMENTS[2920] = Fluid2D([2970,2944,2966],1); -ELEMENTS[2921] = Fluid2D([2966,2944,2938],1); -ELEMENTS[2922] = Fluid2D([2996,2970,2992],1); -ELEMENTS[2923] = Fluid2D([2992,2970,2966],1); -ELEMENTS[2924] = Fluid2D([2992,2966,2987],1); -ELEMENTS[2925] = Fluid2D([2987,2966,2960],1); -ELEMENTS[2926] = Fluid2D([2960,2966,2938],1); -ELEMENTS[2927] = Fluid2D([2960,2938,2934],1); -ELEMENTS[2928] = Fluid2D([2934,2938,2910],1); -ELEMENTS[2929] = Fluid2D([2910,2938,2915],1); -ELEMENTS[2930] = Fluid2D([2915,2938,2944],1); -ELEMENTS[2931] = Fluid2D([2930,2957,2935],1); -ELEMENTS[2932] = Fluid2D([2976,2972,2999],1); -ELEMENTS[2933] = Fluid2D([2999,2972,2996],1); -ELEMENTS[2934] = Fluid2D([2999,2996,3022],1); -ELEMENTS[2935] = Fluid2D([3022,2996,3018],1); -ELEMENTS[2936] = Fluid2D([3018,2996,2992],1); -ELEMENTS[2937] = Fluid2D([2976,2999,3002],1); -ELEMENTS[2938] = Fluid2D([3002,2999,3025],1); -ELEMENTS[2939] = Fluid2D([3002,3025,3028],1); -ELEMENTS[2940] = Fluid2D([3025,2999,3022],1); -ELEMENTS[2941] = Fluid2D([3025,3022,3047],1); -ELEMENTS[2942] = Fluid2D([3047,3022,3044],1); -ELEMENTS[2943] = Fluid2D([3044,3022,3018],1); -ELEMENTS[2944] = Fluid2D([3028,3025,3051],1); -ELEMENTS[2945] = Fluid2D([3028,3051,3053],1); -ELEMENTS[2946] = Fluid2D([3053,3051,3076],1); -ELEMENTS[2947] = Fluid2D([3051,3025,3047],1); -ELEMENTS[2948] = Fluid2D([3076,3051,3073],1); -ELEMENTS[2949] = Fluid2D([3073,3051,3047],1); -ELEMENTS[2950] = Fluid2D([3076,3073,3098],1); -ELEMENTS[2951] = Fluid2D([3076,3098,3101],1); -ELEMENTS[2952] = Fluid2D([3098,3073,3095],1); -ELEMENTS[2953] = Fluid2D([3095,3073,3070],1); -ELEMENTS[2954] = Fluid2D([3098,3095,3121],1); -ELEMENTS[2955] = Fluid2D([3121,3095,3118],1); -ELEMENTS[2956] = Fluid2D([3118,3095,3093],1); -ELEMENTS[2957] = Fluid2D([3093,3095,3070],1); -ELEMENTS[2958] = Fluid2D([3070,3073,3047],1); -ELEMENTS[2959] = Fluid2D([3070,3047,3044],1); -ELEMENTS[2960] = Fluid2D([3070,3044,3067],1); -ELEMENTS[2961] = Fluid2D([3067,3044,3040],1); -ELEMENTS[2962] = Fluid2D([3040,3044,3018],1); -ELEMENTS[2963] = Fluid2D([3040,3018,3014],1); -ELEMENTS[2964] = Fluid2D([3014,3018,2992],1); -ELEMENTS[2965] = Fluid2D([3014,2992,2987],1); -ELEMENTS[2966] = Fluid2D([3014,2987,3009],1); -ELEMENTS[2967] = Fluid2D([3014,3009,3035],1); -ELEMENTS[2968] = Fluid2D([3009,2987,2982],1); -ELEMENTS[2969] = Fluid2D([3101,3098,3123],1); -ELEMENTS[2970] = Fluid2D([3123,3098,3121],1); -ELEMENTS[2971] = Fluid2D([2982,2987,2960],1); -ELEMENTS[2972] = Fluid2D([2982,2960,2956],1); -ELEMENTS[2973] = Fluid2D([2956,2960,2934],1); -ELEMENTS[2974] = Fluid2D([2982,2956,2980],1); -ELEMENTS[2975] = Fluid2D([2980,2956,2954],1); -ELEMENTS[2976] = Fluid2D([2982,2980,3005],1); -ELEMENTS[2977] = Fluid2D([3005,2980,3003],1); -ELEMENTS[2978] = Fluid2D([3003,2980,2978],1); -ELEMENTS[2979] = Fluid2D([2954,2956,2931],1); -ELEMENTS[2980] = Fluid2D([2931,2956,2934],1); -ELEMENTS[2981] = Fluid2D([2931,2934,2908],1); -ELEMENTS[2982] = Fluid2D([2908,2934,2910],1); -ELEMENTS[2983] = Fluid2D([2908,2910,2886],1); -ELEMENTS[2984] = Fluid2D([2886,2910,2888],1); -ELEMENTS[2985] = Fluid2D([2888,2910,2915],1); -ELEMENTS[2986] = Fluid2D([2978,2980,2954],1); -ELEMENTS[2987] = Fluid2D([2978,2954,2952],1); -ELEMENTS[2988] = Fluid2D([2952,2954,2928],1); -ELEMENTS[2989] = Fluid2D([2928,2954,2931],1); -ELEMENTS[2990] = Fluid2D([2978,2952,2975],1); -ELEMENTS[2991] = Fluid2D([2975,2952,2949],1); -ELEMENTS[2992] = Fluid2D([2978,2975,3001],1); -ELEMENTS[2993] = Fluid2D([3001,2975,2998],1); -ELEMENTS[2994] = Fluid2D([2998,2975,2974],1); -ELEMENTS[2995] = Fluid2D([2949,2952,2926],1); -ELEMENTS[2996] = Fluid2D([2926,2952,2928],1); -ELEMENTS[2997] = Fluid2D([2974,2975,2949],1); -ELEMENTS[2998] = Fluid2D([2974,2949,2948],1); -ELEMENTS[2999] = Fluid2D([2926,2928,2903],1); -ELEMENTS[3000] = Fluid2D([2903,2928,2906],1); -ELEMENTS[3001] = Fluid2D([2906,2928,2931],1); -ELEMENTS[3002] = Fluid2D([2948,2949,2923],1); -ELEMENTS[3003] = Fluid2D([2948,2923,2922],1); -ELEMENTS[3004] = Fluid2D([2923,2949,2926],1); -ELEMENTS[3005] = Fluid2D([2923,2926,2900],1); -ELEMENTS[3006] = Fluid2D([2900,2926,2903],1); -ELEMENTS[3007] = Fluid2D([2900,2903,2877],1); -ELEMENTS[3008] = Fluid2D([2877,2903,2880],1); -ELEMENTS[3009] = Fluid2D([2880,2903,2906],1); -ELEMENTS[3010] = Fluid2D([2880,2906,2882],1); -ELEMENTS[3011] = Fluid2D([2882,2906,2908],1); -ELEMENTS[3012] = Fluid2D([2908,2906,2931],1); -ELEMENTS[3013] = Fluid2D([2922,2923,2899],1); -ELEMENTS[3014] = Fluid2D([2899,2923,2900],1); -ELEMENTS[3015] = Fluid2D([2899,2900,2873],1); -ELEMENTS[3016] = Fluid2D([2873,2900,2877],1); -ELEMENTS[3017] = Fluid2D([2873,2877,2851],1); -ELEMENTS[3018] = Fluid2D([2851,2877,2854],1); -ELEMENTS[3019] = Fluid2D([2854,2877,2880],1); -ELEMENTS[3020] = Fluid2D([2851,2854,2828],1); -ELEMENTS[3021] = Fluid2D([2854,2880,2857],1); -ELEMENTS[3022] = Fluid2D([2857,2880,2882],1); -ELEMENTS[3023] = Fluid2D([2828,2854,2830],1); -ELEMENTS[3024] = Fluid2D([2830,2854,2857],1); -ELEMENTS[3025] = Fluid2D([2828,2830,2803],1); -ELEMENTS[3026] = Fluid2D([3035,3009,3031],1); -ELEMENTS[3027] = Fluid2D([3031,3009,3005],1); -ELEMENTS[3028] = Fluid2D([3005,3009,2982],1); -ELEMENTS[3029] = Fluid2D([2803,2830,2807],1); -ELEMENTS[3030] = Fluid2D([2803,2807,2780],1); -ELEMENTS[3031] = Fluid2D([2780,2807,2782],1); -ELEMENTS[3032] = Fluid2D([2803,2780,2777],1); -ELEMENTS[3033] = Fluid2D([2782,2807,2809],1); -ELEMENTS[3034] = Fluid2D([2782,2809,2785],1); -ELEMENTS[3035] = Fluid2D([2777,2780,2753],1); -ELEMENTS[3036] = Fluid2D([2753,2780,2756],1); -ELEMENTS[3037] = Fluid2D([2756,2780,2782],1); -ELEMENTS[3038] = Fluid2D([2828,2803,2801],1); -ELEMENTS[3039] = Fluid2D([2828,2801,2824],1); -ELEMENTS[3040] = Fluid2D([2801,2803,2777],1); -ELEMENTS[3041] = Fluid2D([2824,2801,2797],1); -ELEMENTS[3042] = Fluid2D([2797,2801,2774],1); -ELEMENTS[3043] = Fluid2D([2774,2801,2777],1); -ELEMENTS[3044] = Fluid2D([2774,2777,2751],1); -ELEMENTS[3045] = Fluid2D([2751,2777,2753],1); -ELEMENTS[3046] = Fluid2D([2774,2751,2745],1); -ELEMENTS[3047] = Fluid2D([2745,2751,2723],1); -ELEMENTS[3048] = Fluid2D([2723,2751,2726],1); -ELEMENTS[3049] = Fluid2D([2726,2751,2753],1); -ELEMENTS[3050] = Fluid2D([2774,2745,2772],1); -ELEMENTS[3051] = Fluid2D([2772,2745,2744],1); -ELEMENTS[3052] = Fluid2D([2774,2772,2797],1); -ELEMENTS[3053] = Fluid2D([2744,2745,2719],1); -ELEMENTS[3054] = Fluid2D([2719,2745,2723],1); -ELEMENTS[3055] = Fluid2D([2719,2723,2694],1); -ELEMENTS[3056] = Fluid2D([2694,2723,2699],1); -ELEMENTS[3057] = Fluid2D([2699,2723,2726],1); -ELEMENTS[3058] = Fluid2D([2797,2772,2795],1); -ELEMENTS[3059] = Fluid2D([2797,2795,2823],1); -ELEMENTS[3060] = Fluid2D([2823,2795,2818],1); -ELEMENTS[3061] = Fluid2D([2818,2795,2791],1); -ELEMENTS[3062] = Fluid2D([2791,2795,2768],1); -ELEMENTS[3063] = Fluid2D([2768,2795,2772],1); -ELEMENTS[3064] = Fluid2D([2768,2772,2744],1); -ELEMENTS[3065] = Fluid2D([2768,2744,2722],1); -ELEMENTS[3066] = Fluid2D([2785,2809,2812],1); -ELEMENTS[3067] = Fluid2D([2791,2768,2747],1); -ELEMENTS[3068] = Fluid2D([3070,3067,3093],1); -ELEMENTS[3069] = Fluid2D([3093,3067,3089],1); -ELEMENTS[3070] = Fluid2D([3089,3067,3063],1); -ELEMENTS[3071] = Fluid2D([3093,3089,3115],1); -ELEMENTS[3072] = Fluid2D([3115,3089,3112],1); -ELEMENTS[3073] = Fluid2D([3112,3089,3084],1); -ELEMENTS[3074] = Fluid2D([3115,3112,3138],1); -ELEMENTS[3075] = Fluid2D([3138,3112,3134],1); -ELEMENTS[3076] = Fluid2D([3134,3112,3107],1); -ELEMENTS[3077] = Fluid2D([3107,3112,3084],1); -ELEMENTS[3078] = Fluid2D([3084,3089,3063],1); -ELEMENTS[3079] = Fluid2D([3084,3063,3058],1); -ELEMENTS[3080] = Fluid2D([3058,3063,3035],1); -ELEMENTS[3081] = Fluid2D([3035,3063,3040],1); -ELEMENTS[3082] = Fluid2D([3084,3058,3080],1); -ELEMENTS[3083] = Fluid2D([3080,3058,3054],1); -ELEMENTS[3084] = Fluid2D([3054,3058,3031],1); -ELEMENTS[3085] = Fluid2D([3031,3058,3035],1); -ELEMENTS[3086] = Fluid2D([3063,3067,3040],1); -ELEMENTS[3087] = Fluid2D([2802,2806,2779],1); -ELEMENTS[3088] = Fluid2D([3134,3107,3129],1); -ELEMENTS[3089] = Fluid2D([3129,3107,3103],1); -ELEMENTS[3090] = Fluid2D([3134,3129,3154],1); -ELEMENTS[3091] = Fluid2D([3134,3154,3160],1); -ELEMENTS[3092] = Fluid2D([3154,3129,3150],1); -ELEMENTS[3093] = Fluid2D([3154,3150,3176],1); -ELEMENTS[3094] = Fluid2D([3176,3150,3172],1); -ELEMENTS[3095] = Fluid2D([3172,3150,3147],1); -ELEMENTS[3096] = Fluid2D([3147,3150,3124],1); -ELEMENTS[3097] = Fluid2D([3124,3150,3129],1); -ELEMENTS[3098] = Fluid2D([3124,3129,3103],1); -ELEMENTS[3099] = Fluid2D([3160,3154,3182],1); -ELEMENTS[3100] = Fluid2D([3160,3182,3185],1); -ELEMENTS[3101] = Fluid2D([3182,3154,3176],1); -ELEMENTS[3102] = Fluid2D([3103,3107,3080],1); -ELEMENTS[3103] = Fluid2D([3103,3080,3077],1); -ELEMENTS[3104] = Fluid2D([3080,3107,3084],1); -ELEMENTS[3105] = Fluid2D([3185,3182,3207],1); -ELEMENTS[3106] = Fluid2D([3207,3182,3202],1); -ELEMENTS[3107] = Fluid2D([3202,3182,3176],1); -ELEMENTS[3108] = Fluid2D([3207,3202,3228],1); -ELEMENTS[3109] = Fluid2D([3207,3228,3233],1); -ELEMENTS[3110] = Fluid2D([3228,3202,3221],1); -ELEMENTS[3111] = Fluid2D([3221,3202,3197],1); -ELEMENTS[3112] = Fluid2D([3233,3228,3255],1); -ELEMENTS[3113] = Fluid2D([3255,3228,3246],1); -ELEMENTS[3114] = Fluid2D([3246,3228,3221],1); -ELEMENTS[3115] = Fluid2D([3197,3202,3176],1); -ELEMENTS[3116] = Fluid2D([3197,3176,3172],1); -ELEMENTS[3117] = Fluid2D([3197,3172,3195],1); -ELEMENTS[3118] = Fluid2D([3195,3172,3170],1); -ELEMENTS[3119] = Fluid2D([3197,3195,3220],1); -ELEMENTS[3120] = Fluid2D([3220,3195,3218],1); -ELEMENTS[3121] = Fluid2D([3218,3195,3193],1); -ELEMENTS[3122] = Fluid2D([3193,3195,3170],1); -ELEMENTS[3123] = Fluid2D([3193,3170,3168],1); -ELEMENTS[3124] = Fluid2D([3168,3170,3145],1); -ELEMENTS[3125] = Fluid2D([3145,3170,3147],1); -ELEMENTS[3126] = Fluid2D([3147,3170,3172],1); -ELEMENTS[3127] = Fluid2D([3077,3080,3054],1); -ELEMENTS[3128] = Fluid2D([3077,3054,3052],1); -ELEMENTS[3129] = Fluid2D([3052,3054,3029],1); -ELEMENTS[3130] = Fluid2D([3029,3054,3031],1); -ELEMENTS[3131] = Fluid2D([3077,3052,3074],1); -ELEMENTS[3132] = Fluid2D([3074,3052,3050],1); -ELEMENTS[3133] = Fluid2D([3077,3074,3100],1); -ELEMENTS[3134] = Fluid2D([3100,3074,3097],1); -ELEMENTS[3135] = Fluid2D([3097,3074,3072],1); -ELEMENTS[3136] = Fluid2D([3050,3052,3027],1); -ELEMENTS[3137] = Fluid2D([3027,3052,3029],1); -ELEMENTS[3138] = Fluid2D([3072,3074,3050],1); -ELEMENTS[3139] = Fluid2D([3072,3050,3046],1); -ELEMENTS[3140] = Fluid2D([3046,3050,3024],1); -ELEMENTS[3141] = Fluid2D([3046,3024,3023],1); -ELEMENTS[3142] = Fluid2D([3024,3050,3027],1); -ELEMENTS[3143] = Fluid2D([3024,3027,3001],1); -ELEMENTS[3144] = Fluid2D([3001,3027,3003],1); -ELEMENTS[3145] = Fluid2D([3003,3027,3029],1); -ELEMENTS[3146] = Fluid2D([3023,3024,2998],1); -ELEMENTS[3147] = Fluid2D([2998,3024,3001],1); -ELEMENTS[3148] = Fluid2D([3023,2998,2997],1); -ELEMENTS[3149] = Fluid2D([3023,2997,3019],1); -ELEMENTS[3150] = Fluid2D([3019,2997,2994],1); -ELEMENTS[3151] = Fluid2D([2994,2997,2971],1); -ELEMENTS[3152] = Fluid2D([2971,2997,2974],1); -ELEMENTS[3153] = Fluid2D([2974,2997,2998],1); -ELEMENTS[3154] = Fluid2D([3029,3031,3005],1); -ELEMENTS[3155] = Fluid2D([3029,3005,3003],1); -ELEMENTS[3156] = Fluid2D([3124,3103,3100],1); -ELEMENTS[3157] = Fluid2D([3100,3103,3077],1); -ELEMENTS[3158] = Fluid2D([3124,3100,3122],1); -ELEMENTS[3159] = Fluid2D([3124,3122,3147],1); -ELEMENTS[3160] = Fluid2D([3147,3122,3145],1); -ELEMENTS[3161] = Fluid2D([3145,3122,3120],1); -ELEMENTS[3162] = Fluid2D([3120,3122,3097],1); -ELEMENTS[3163] = Fluid2D([3120,3097,3096],1); -ELEMENTS[3164] = Fluid2D([3096,3097,3072],1); -ELEMENTS[3165] = Fluid2D([3096,3072,3071],1); -ELEMENTS[3166] = Fluid2D([3071,3072,3046],1); -ELEMENTS[3167] = Fluid2D([3071,3046,3045],1); -ELEMENTS[3168] = Fluid2D([3045,3046,3023],1); -ELEMENTS[3169] = Fluid2D([3045,3023,3019],1); -ELEMENTS[3170] = Fluid2D([3071,3045,3068],1); -ELEMENTS[3171] = Fluid2D([3068,3045,3042],1); -ELEMENTS[3172] = Fluid2D([3071,3068,3094],1); -ELEMENTS[3173] = Fluid2D([3094,3068,3092],1); -ELEMENTS[3174] = Fluid2D([3092,3068,3066],1); -ELEMENTS[3175] = Fluid2D([3042,3045,3019],1); -ELEMENTS[3176] = Fluid2D([3066,3068,3042],1); -ELEMENTS[3177] = Fluid2D([3066,3042,3041],1); -ELEMENTS[3178] = Fluid2D([3041,3042,3017],1); -ELEMENTS[3179] = Fluid2D([3041,3017,3015],1); -ELEMENTS[3180] = Fluid2D([3017,3042,3019],1); -ELEMENTS[3181] = Fluid2D([3017,3019,2994],1); -ELEMENTS[3182] = Fluid2D([3015,3017,2993],1); -ELEMENTS[3183] = Fluid2D([2993,3017,2994],1); -ELEMENTS[3184] = Fluid2D([3097,3122,3100],1); -ELEMENTS[3185] = Fluid2D([2993,2994,2969],1); -ELEMENTS[3186] = Fluid2D([2969,2994,2971],1); -ELEMENTS[3187] = Fluid2D([2993,2969,2967],1); -ELEMENTS[3188] = Fluid2D([2967,2969,2943],1); -ELEMENTS[3189] = Fluid2D([2943,2969,2945],1); -ELEMENTS[3190] = Fluid2D([2945,2969,2971],1); -ELEMENTS[3191] = Fluid2D([2945,2971,2948],1); -ELEMENTS[3192] = Fluid2D([2948,2971,2974],1); -ELEMENTS[3193] = Fluid2D([2945,2948,2922],1); -ELEMENTS[3194] = Fluid2D([2945,2922,2919],1); -ELEMENTS[3195] = Fluid2D([2945,2919,2943],1); -ELEMENTS[3196] = Fluid2D([2919,2922,2895],1); -ELEMENTS[3197] = Fluid2D([2895,2922,2899],1); -ELEMENTS[3198] = Fluid2D([2943,2919,2916],1); -ELEMENTS[3199] = Fluid2D([2943,2916,2940],1); -ELEMENTS[3200] = Fluid2D([2940,2916,2914],1); -ELEMENTS[3201] = Fluid2D([2914,2916,2889],1); -ELEMENTS[3202] = Fluid2D([2889,2916,2893],1); -ELEMENTS[3203] = Fluid2D([2893,2916,2919],1); -ELEMENTS[3204] = Fluid2D([2893,2919,2895],1); -ELEMENTS[3205] = Fluid2D([2889,2893,2866],1); -ELEMENTS[3206] = Fluid2D([2866,2893,2868],1); -ELEMENTS[3207] = Fluid2D([2868,2893,2895],1); -ELEMENTS[3208] = Fluid2D([2868,2895,2872],1); -ELEMENTS[3209] = Fluid2D([2872,2895,2899],1); -ELEMENTS[3210] = Fluid2D([2868,2872,2845],1); -ELEMENTS[3211] = Fluid2D([2866,2868,2842],1); -ELEMENTS[3212] = Fluid2D([2842,2868,2845],1); -ELEMENTS[3213] = Fluid2D([2842,2845,2818],1); -ELEMENTS[3214] = Fluid2D([2842,2818,2815],1); -ELEMENTS[3215] = Fluid2D([2815,2818,2791],1); -ELEMENTS[3216] = Fluid2D([2845,2872,2847],1); -ELEMENTS[3217] = Fluid2D([2847,2872,2873],1); -ELEMENTS[3218] = Fluid2D([2873,2872,2899],1); -ELEMENTS[3219] = Fluid2D([2845,2847,2823],1); -ELEMENTS[3220] = Fluid2D([2823,2847,2824],1); -ELEMENTS[3221] = Fluid2D([2824,2847,2851],1); -ELEMENTS[3222] = Fluid2D([2851,2847,2873],1); -ELEMENTS[3223] = Fluid2D([2823,2824,2797],1); -ELEMENTS[3224] = Fluid2D([2818,2845,2823],1); -ELEMENTS[3225] = Fluid2D([3160,3185,3163],1); -ELEMENTS[3226] = Fluid2D([3163,3185,3189],1); -ELEMENTS[3227] = Fluid2D([3160,3163,3138],1); -ELEMENTS[3228] = Fluid2D([3189,3185,3210],1); -ELEMENTS[3229] = Fluid2D([3210,3185,3207],1); -ELEMENTS[3230] = Fluid2D([3138,3163,3141],1); -ELEMENTS[3231] = Fluid2D([3141,3163,3166],1); -ELEMENTS[3232] = Fluid2D([3166,3163,3189],1); -ELEMENTS[3233] = Fluid2D([3166,3189,3191],1); -ELEMENTS[3234] = Fluid2D([3191,3189,3213],1); -ELEMENTS[3235] = Fluid2D([3213,3189,3210],1); -ELEMENTS[3236] = Fluid2D([3166,3191,3169],1); -ELEMENTS[3237] = Fluid2D([3169,3191,3194],1); -ELEMENTS[3238] = Fluid2D([3166,3169,3143],1); -ELEMENTS[3239] = Fluid2D([3143,3169,3146],1); -ELEMENTS[3240] = Fluid2D([3146,3169,3171],1); -ELEMENTS[3241] = Fluid2D([3194,3191,3216],1); -ELEMENTS[3242] = Fluid2D([3216,3191,3213],1); -ELEMENTS[3243] = Fluid2D([3216,3213,3238],1); -ELEMENTS[3244] = Fluid2D([3238,3213,3236],1); -ELEMENTS[3245] = Fluid2D([3236,3213,3210],1); -ELEMENTS[3246] = Fluid2D([3236,3210,3233],1); -ELEMENTS[3247] = Fluid2D([3233,3210,3207],1); -ELEMENTS[3248] = Fluid2D([3171,3169,3194],1); -ELEMENTS[3249] = Fluid2D([3171,3194,3196],1); -ELEMENTS[3250] = Fluid2D([3196,3194,3219],1); -ELEMENTS[3251] = Fluid2D([3219,3194,3216],1); -ELEMENTS[3252] = Fluid2D([3216,3238,3241],1); -ELEMENTS[3253] = Fluid2D([3241,3238,3263],1); -ELEMENTS[3254] = Fluid2D([3263,3238,3261],1); -ELEMENTS[3255] = Fluid2D([3263,3261,3286],1); -ELEMENTS[3256] = Fluid2D([3286,3261,3282],1); -ELEMENTS[3257] = Fluid2D([3282,3261,3258],1); -ELEMENTS[3258] = Fluid2D([3258,3261,3236],1); -ELEMENTS[3259] = Fluid2D([3236,3261,3238],1); -ELEMENTS[3260] = Fluid2D([3286,3282,3308],1); -ELEMENTS[3261] = Fluid2D([3308,3282,3305],1); -ELEMENTS[3262] = Fluid2D([3305,3282,3280],1); -ELEMENTS[3263] = Fluid2D([3280,3282,3258],1); -ELEMENTS[3264] = Fluid2D([3305,3280,3302],1); -ELEMENTS[3265] = Fluid2D([3302,3280,3272],1); -ELEMENTS[3266] = Fluid2D([3305,3302,3324],1); -ELEMENTS[3267] = Fluid2D([3324,3302,3318],1); -ELEMENTS[3268] = Fluid2D([3318,3302,3293],1); -ELEMENTS[3269] = Fluid2D([3293,3302,3272],1); -ELEMENTS[3270] = Fluid2D([3272,3280,3255],1); -ELEMENTS[3271] = Fluid2D([3255,3280,3258],1); -ELEMENTS[3272] = Fluid2D([3272,3255,3246],1); -ELEMENTS[3273] = Fluid2D([3272,3246,3268],1); -ELEMENTS[3274] = Fluid2D([3268,3246,3244],1); -ELEMENTS[3275] = Fluid2D([3268,3244,3266],1); -ELEMENTS[3276] = Fluid2D([3244,3246,3221],1); -ELEMENTS[3277] = Fluid2D([3244,3221,3220],1); -ELEMENTS[3278] = Fluid2D([3220,3221,3197],1); -ELEMENTS[3279] = Fluid2D([3266,3244,3243],1); -ELEMENTS[3280] = Fluid2D([3243,3244,3220],1); -ELEMENTS[3281] = Fluid2D([3243,3220,3218],1); -ELEMENTS[3282] = Fluid2D([3243,3218,3240],1); -ELEMENTS[3283] = Fluid2D([3240,3218,3217],1); -ELEMENTS[3284] = Fluid2D([3217,3218,3193],1); -ELEMENTS[3285] = Fluid2D([3217,3193,3192],1); -ELEMENTS[3286] = Fluid2D([3192,3193,3168],1); -ELEMENTS[3287] = Fluid2D([3192,3168,3167],1); -ELEMENTS[3288] = Fluid2D([3167,3168,3144],1); -ELEMENTS[3289] = Fluid2D([3144,3168,3145],1); -ELEMENTS[3290] = Fluid2D([3144,3145,3120],1); -ELEMENTS[3291] = Fluid2D([3144,3120,3119],1); -ELEMENTS[3292] = Fluid2D([3119,3120,3096],1); -ELEMENTS[3293] = Fluid2D([3119,3096,3094],1); -ELEMENTS[3294] = Fluid2D([3094,3096,3071],1); -ELEMENTS[3295] = Fluid2D([3240,3217,3239],1); -ELEMENTS[3296] = Fluid2D([3239,3217,3214],1); -ELEMENTS[3297] = Fluid2D([3239,3214,3237],1); -ELEMENTS[3298] = Fluid2D([3214,3217,3192],1); -ELEMENTS[3299] = Fluid2D([3214,3192,3190],1); -ELEMENTS[3300] = Fluid2D([3190,3192,3167],1); -ELEMENTS[3301] = Fluid2D([3190,3167,3165],1); -ELEMENTS[3302] = Fluid2D([3165,3167,3142],1); -ELEMENTS[3303] = Fluid2D([3142,3167,3144],1); -ELEMENTS[3304] = Fluid2D([3142,3144,3119],1); -ELEMENTS[3305] = Fluid2D([3142,3119,3117],1); -ELEMENTS[3306] = Fluid2D([3117,3119,3094],1); -ELEMENTS[3307] = Fluid2D([3117,3094,3092],1); -ELEMENTS[3308] = Fluid2D([3237,3214,3212],1); -ELEMENTS[3309] = Fluid2D([3237,3212,3235],1); -ELEMENTS[3310] = Fluid2D([3235,3212,3211],1); -ELEMENTS[3311] = Fluid2D([3211,3212,3187],1); -ELEMENTS[3312] = Fluid2D([3187,3212,3190],1); -ELEMENTS[3313] = Fluid2D([3190,3212,3214],1); -ELEMENTS[3314] = Fluid2D([3216,3241,3219],1); -ELEMENTS[3315] = Fluid2D([3190,3165,3187],1); -ELEMENTS[3316] = Fluid2D([3187,3165,3164],1); -ELEMENTS[3317] = Fluid2D([3187,3164,3186],1); -ELEMENTS[3318] = Fluid2D([3164,3165,3140],1); -ELEMENTS[3319] = Fluid2D([3186,3164,3162],1); -ELEMENTS[3320] = Fluid2D([3187,3186,3211],1); -ELEMENTS[3321] = Fluid2D([3211,3186,3209],1); -ELEMENTS[3322] = Fluid2D([3209,3186,3184],1); -ELEMENTS[3323] = Fluid2D([3140,3165,3142],1); -ELEMENTS[3324] = Fluid2D([3140,3142,3117],1); -ELEMENTS[3325] = Fluid2D([3140,3117,3116],1); -ELEMENTS[3326] = Fluid2D([3116,3117,3092],1); -ELEMENTS[3327] = Fluid2D([3116,3092,3090],1); -ELEMENTS[3328] = Fluid2D([3090,3092,3066],1); -ELEMENTS[3329] = Fluid2D([3090,3066,3064],1); -ELEMENTS[3330] = Fluid2D([3064,3066,3041],1); -ELEMENTS[3331] = Fluid2D([3064,3041,3039],1); -ELEMENTS[3332] = Fluid2D([3039,3041,3015],1); -ELEMENTS[3333] = Fluid2D([3039,3015,3012],1); -ELEMENTS[3334] = Fluid2D([3012,3015,2989],1); -ELEMENTS[3335] = Fluid2D([2989,3015,2993],1); -ELEMENTS[3336] = Fluid2D([3184,3186,3162],1); -ELEMENTS[3337] = Fluid2D([3184,3162,3159],1); -ELEMENTS[3338] = Fluid2D([3159,3162,3137],1); -ELEMENTS[3339] = Fluid2D([3137,3162,3139],1); -ELEMENTS[3340] = Fluid2D([3139,3162,3164],1); -ELEMENTS[3341] = Fluid2D([3139,3164,3140],1); -ELEMENTS[3342] = Fluid2D([3139,3140,3116],1); -ELEMENTS[3343] = Fluid2D([3139,3116,3113],1); -ELEMENTS[3344] = Fluid2D([3139,3113,3137],1); -ELEMENTS[3345] = Fluid2D([3137,3113,3111],1); -ELEMENTS[3346] = Fluid2D([3111,3113,3088],1); -ELEMENTS[3347] = Fluid2D([2989,2993,2967],1); -ELEMENTS[3348] = Fluid2D([3113,3116,3090],1); -ELEMENTS[3349] = Fluid2D([3088,3113,3090],1); -ELEMENTS[3350] = Fluid2D([3088,3090,3064],1); -ELEMENTS[3351] = Fluid2D([3088,3064,3062],1); -ELEMENTS[3352] = Fluid2D([3088,3062,3086],1); -ELEMENTS[3353] = Fluid2D([3086,3062,3060],1); -ELEMENTS[3354] = Fluid2D([3088,3086,3111],1); -ELEMENTS[3355] = Fluid2D([3111,3086,3109],1); -ELEMENTS[3356] = Fluid2D([3111,3109,3135],1); -ELEMENTS[3357] = Fluid2D([3135,3109,3132],1); -ELEMENTS[3358] = Fluid2D([3132,3109,3106],1); -ELEMENTS[3359] = Fluid2D([3106,3109,3083],1); -ELEMENTS[3360] = Fluid2D([3083,3109,3086],1); -ELEMENTS[3361] = Fluid2D([3062,3064,3039],1); -ELEMENTS[3362] = Fluid2D([3060,3062,3036],1); -ELEMENTS[3363] = Fluid2D([3036,3062,3039],1); -ELEMENTS[3364] = Fluid2D([3083,3086,3060],1); -ELEMENTS[3365] = Fluid2D([3083,3060,3057],1); -ELEMENTS[3366] = Fluid2D([3057,3060,3034],1); -ELEMENTS[3367] = Fluid2D([3034,3060,3036],1); -ELEMENTS[3368] = Fluid2D([3034,3036,3010],1); -ELEMENTS[3369] = Fluid2D([3010,3036,3012],1); -ELEMENTS[3370] = Fluid2D([3057,3034,3032],1); -ELEMENTS[3371] = Fluid2D([3032,3034,3008],1); -ELEMENTS[3372] = Fluid2D([3008,3034,3010],1); -ELEMENTS[3373] = Fluid2D([3008,3010,2985],1); -ELEMENTS[3374] = Fluid2D([2985,3010,2986],1); -ELEMENTS[3375] = Fluid2D([2986,3010,3012],1); -ELEMENTS[3376] = Fluid2D([3036,3039,3012],1); -ELEMENTS[3377] = Fluid2D([3111,3135,3137],1); -ELEMENTS[3378] = Fluid2D([3137,3135,3159],1); -ELEMENTS[3379] = Fluid2D([3159,3135,3158],1); -ELEMENTS[3380] = Fluid2D([3159,3158,3183],1); -ELEMENTS[3381] = Fluid2D([3158,3135,3132],1); -ELEMENTS[3382] = Fluid2D([3159,3183,3184],1); -ELEMENTS[3383] = Fluid2D([3184,3183,3208],1); -ELEMENTS[3384] = Fluid2D([3208,3183,3206],1); -ELEMENTS[3385] = Fluid2D([3208,3206,3231],1); -ELEMENTS[3386] = Fluid2D([3206,3183,3180],1); -ELEMENTS[3387] = Fluid2D([3231,3206,3226],1); -ELEMENTS[3388] = Fluid2D([3226,3206,3203],1); -ELEMENTS[3389] = Fluid2D([3183,3158,3180],1); -ELEMENTS[3390] = Fluid2D([3180,3158,3155],1); -ELEMENTS[3391] = Fluid2D([3180,3155,3178],1); -ELEMENTS[3392] = Fluid2D([3203,3206,3180],1); -ELEMENTS[3393] = Fluid2D([3203,3180,3178],1); -ELEMENTS[3394] = Fluid2D([3203,3178,3200],1); -ELEMENTS[3395] = Fluid2D([3155,3158,3132],1); -ELEMENTS[3396] = Fluid2D([3178,3155,3152],1); -ELEMENTS[3397] = Fluid2D([3152,3155,3130],1); -ELEMENTS[3398] = Fluid2D([3130,3155,3132],1); -ELEMENTS[3399] = Fluid2D([3200,3178,3175],1); -ELEMENTS[3400] = Fluid2D([3175,3178,3152],1); -ELEMENTS[3401] = Fluid2D([3175,3152,3151],1); -ELEMENTS[3402] = Fluid2D([3175,3151,3173],1); -ELEMENTS[3403] = Fluid2D([3173,3151,3149],1); -ELEMENTS[3404] = Fluid2D([3149,3151,3125],1); -ELEMENTS[3405] = Fluid2D([3125,3151,3127],1); -ELEMENTS[3406] = Fluid2D([3127,3151,3152],1); -ELEMENTS[3407] = Fluid2D([3127,3152,3130],1); -ELEMENTS[3408] = Fluid2D([3127,3130,3105],1); -ELEMENTS[3409] = Fluid2D([3127,3105,3104],1); -ELEMENTS[3410] = Fluid2D([3105,3130,3106],1); -ELEMENTS[3411] = Fluid2D([3104,3105,3079],1); -ELEMENTS[3412] = Fluid2D([3079,3105,3082],1); -ELEMENTS[3413] = Fluid2D([3082,3105,3106],1); -ELEMENTS[3414] = Fluid2D([3106,3130,3132],1); -ELEMENTS[3415] = Fluid2D([3008,2985,2983],1); -ELEMENTS[3416] = Fluid2D([3008,2983,3007],1); -ELEMENTS[3417] = Fluid2D([3007,2983,2965],1); -ELEMENTS[3418] = Fluid2D([2983,2985,2958],1); -ELEMENTS[3419] = Fluid2D([2983,2958,2941],1); -ELEMENTS[3420] = Fluid2D([2958,2985,2961],1); -ELEMENTS[3421] = Fluid2D([2961,2985,2986],1); -ELEMENTS[3422] = Fluid2D([2961,2986,2964],1); -ELEMENTS[3423] = Fluid2D([2964,2986,2989],1); -ELEMENTS[3424] = Fluid2D([2989,2986,3012],1); -ELEMENTS[3425] = Fluid2D([3008,3007,3032],1); -ELEMENTS[3426] = Fluid2D([2958,2961,2936],1); -ELEMENTS[3427] = Fluid2D([2936,2961,2937],1); -ELEMENTS[3428] = Fluid2D([2937,2961,2964],1); -ELEMENTS[3429] = Fluid2D([2937,2964,2940],1); -ELEMENTS[3430] = Fluid2D([3032,3007,3030],1); -ELEMENTS[3431] = Fluid2D([3030,3007,2988],1); -ELEMENTS[3432] = Fluid2D([3032,3030,3056],1); -ELEMENTS[3433] = Fluid2D([3032,3056,3057],1); -ELEMENTS[3434] = Fluid2D([3056,3030,3055],1); -ELEMENTS[3435] = Fluid2D([3055,3030,3013],1); -ELEMENTS[3436] = Fluid2D([3057,3056,3082],1); -ELEMENTS[3437] = Fluid2D([3082,3056,3079],1); -ELEMENTS[3438] = Fluid2D([3057,3082,3083],1); -ELEMENTS[3439] = Fluid2D([3079,3056,3055],1); -ELEMENTS[3440] = Fluid2D([3079,3055,3078],1); -ELEMENTS[3441] = Fluid2D([3078,3055,3037],1); -ELEMENTS[3442] = Fluid2D([3079,3078,3104],1); -ELEMENTS[3443] = Fluid2D([3104,3078,3099],1); -ELEMENTS[3444] = Fluid2D([3099,3078,3061],1); -ELEMENTS[3445] = Fluid2D([2940,2964,2967],1); -ELEMENTS[3446] = Fluid2D([2967,2964,2989],1); -ELEMENTS[3447] = Fluid2D([2940,2967,2943],1); -ELEMENTS[3448] = Fluid2D([3203,3200,3224],1); -ELEMENTS[3449] = Fluid2D([3224,3200,3222],1); -ELEMENTS[3450] = Fluid2D([3222,3200,3198],1); -ELEMENTS[3451] = Fluid2D([3198,3200,3175],1); -ELEMENTS[3452] = Fluid2D([3222,3198,3223],1); -ELEMENTS[3453] = Fluid2D([3222,3223,3247],1); -ELEMENTS[3454] = Fluid2D([3247,3223,3251],1); -ELEMENTS[3455] = Fluid2D([3203,3224,3226],1); -ELEMENTS[3456] = Fluid2D([3226,3224,3248],1); -ELEMENTS[3457] = Fluid2D([3248,3224,3245],1); -ELEMENTS[3458] = Fluid2D([3223,3198,3199],1); -ELEMENTS[3459] = Fluid2D([3199,3198,3173],1); -ELEMENTS[3460] = Fluid2D([3173,3198,3175],1); -ELEMENTS[3461] = Fluid2D([3226,3248,3253],1); -ELEMENTS[3462] = Fluid2D([3226,3253,3231],1); -ELEMENTS[3463] = Fluid2D([3231,3253,3256],1); -ELEMENTS[3464] = Fluid2D([3256,3253,3277],1); -ELEMENTS[3465] = Fluid2D([3277,3253,3271],1); -ELEMENTS[3466] = Fluid2D([3245,3224,3222],1); -ELEMENTS[3467] = Fluid2D([3271,3253,3248],1); -ELEMENTS[3468] = Fluid2D([3271,3248,3270],1); -ELEMENTS[3469] = Fluid2D([3270,3248,3245],1); -ELEMENTS[3470] = Fluid2D([3271,3270,3295],1); -ELEMENTS[3471] = Fluid2D([3271,3295,3299],1); -ELEMENTS[3472] = Fluid2D([3295,3270,3291],1); -ELEMENTS[3473] = Fluid2D([3299,3295,3319],1); -ELEMENTS[3474] = Fluid2D([3270,3245,3269],1); -ELEMENTS[3475] = Fluid2D([3269,3245,3247],1); -ELEMENTS[3476] = Fluid2D([3247,3245,3222],1); -ELEMENTS[3477] = Fluid2D([3319,3295,3317],1); -ELEMENTS[3478] = Fluid2D([3319,3317,3342],1); -ELEMENTS[3479] = Fluid2D([3342,3317,3340],1); -ELEMENTS[3480] = Fluid2D([3340,3317,3316],1); -ELEMENTS[3481] = Fluid2D([3316,3317,3291],1); -ELEMENTS[3482] = Fluid2D([3291,3317,3295],1); -ELEMENTS[3483] = Fluid2D([3291,3270,3269],1); -ELEMENTS[3484] = Fluid2D([3291,3269,3294],1); -ELEMENTS[3485] = Fluid2D([3294,3269,3284],1); -ELEMENTS[3486] = Fluid2D([3291,3294,3316],1); -ELEMENTS[3487] = Fluid2D([3316,3294,3314],1); -ELEMENTS[3488] = Fluid2D([3316,3314,3339],1); -ELEMENTS[3489] = Fluid2D([3339,3314,3338],1); -ELEMENTS[3490] = Fluid2D([3314,3294,3284],1); -ELEMENTS[3491] = Fluid2D([3316,3339,3340],1); -ELEMENTS[3492] = Fluid2D([3340,3339,3364],1); -ELEMENTS[3493] = Fluid2D([3340,3364,3365],1); -ELEMENTS[3494] = Fluid2D([3364,3339,3362],1); -ELEMENTS[3495] = Fluid2D([3365,3364,3389],1); -ELEMENTS[3496] = Fluid2D([3389,3364,3387],1); -ELEMENTS[3497] = Fluid2D([3338,3314,3309],1); -ELEMENTS[3498] = Fluid2D([3362,3339,3338],1); -ELEMENTS[3499] = Fluid2D([3362,3338,3361],1); -ELEMENTS[3500] = Fluid2D([3362,3361,3386],1); -ELEMENTS[3501] = Fluid2D([3386,3361,3385],1); -ELEMENTS[3502] = Fluid2D([3387,3364,3362],1); -ELEMENTS[3503] = Fluid2D([3387,3362,3386],1); -ELEMENTS[3504] = Fluid2D([3387,3386,3411],1); -ELEMENTS[3505] = Fluid2D([3361,3338,3334],1); -ELEMENTS[3506] = Fluid2D([3334,3338,3309],1); -ELEMENTS[3507] = Fluid2D([3385,3361,3360],1); -ELEMENTS[3508] = Fluid2D([3360,3361,3334],1); -ELEMENTS[3509] = Fluid2D([3385,3360,3383],1); -ELEMENTS[3510] = Fluid2D([3360,3334,3333],1); -ELEMENTS[3511] = Fluid2D([3333,3334,3301],1); -ELEMENTS[3512] = Fluid2D([3383,3360,3357],1); -ELEMENTS[3513] = Fluid2D([3383,3357,3382],1); -ELEMENTS[3514] = Fluid2D([3382,3357,3356],1); -ELEMENTS[3515] = Fluid2D([3356,3357,3329],1); -ELEMENTS[3516] = Fluid2D([3357,3360,3333],1); -ELEMENTS[3517] = Fluid2D([3411,3386,3409],1); -ELEMENTS[3518] = Fluid2D([3411,3409,3434],1); -ELEMENTS[3519] = Fluid2D([3434,3409,3433],1); -ELEMENTS[3520] = Fluid2D([3433,3409,3408],1); -ELEMENTS[3521] = Fluid2D([3408,3409,3385],1); -ELEMENTS[3522] = Fluid2D([3385,3409,3386],1); -ELEMENTS[3523] = Fluid2D([3357,3333,3329],1); -ELEMENTS[3524] = Fluid2D([3340,3365,3342],1); -ELEMENTS[3525] = Fluid2D([3342,3365,3367],1); -ELEMENTS[3526] = Fluid2D([3342,3367,3344],1); -ELEMENTS[3527] = Fluid2D([3367,3365,3390],1); -ELEMENTS[3528] = Fluid2D([3390,3365,3389],1); -ELEMENTS[3529] = Fluid2D([3390,3389,3413],1); -ELEMENTS[3530] = Fluid2D([3413,3389,3412],1); -ELEMENTS[3531] = Fluid2D([3412,3389,3387],1); -ELEMENTS[3532] = Fluid2D([3342,3344,3319],1); -ELEMENTS[3533] = Fluid2D([3319,3344,3322],1); -ELEMENTS[3534] = Fluid2D([3322,3344,3346],1); -ELEMENTS[3535] = Fluid2D([3346,3344,3369],1); -ELEMENTS[3536] = Fluid2D([3319,3322,3299],1); -ELEMENTS[3537] = Fluid2D([3299,3322,3303],1); -ELEMENTS[3538] = Fluid2D([3303,3322,3325],1); -ELEMENTS[3539] = Fluid2D([3325,3322,3346],1); -ELEMENTS[3540] = Fluid2D([3369,3344,3367],1); -ELEMENTS[3541] = Fluid2D([3369,3367,3391],1); -ELEMENTS[3542] = Fluid2D([3391,3367,3390],1); -ELEMENTS[3543] = Fluid2D([3369,3391,3394],1); -ELEMENTS[3544] = Fluid2D([3391,3390,3415],1); -ELEMENTS[3545] = Fluid2D([3394,3391,3417],1); -ELEMENTS[3546] = Fluid2D([3415,3390,3413],1); -ELEMENTS[3547] = Fluid2D([3415,3413,3438],1); -ELEMENTS[3548] = Fluid2D([3438,3413,3437],1); -ELEMENTS[3549] = Fluid2D([3417,3391,3415],1); -ELEMENTS[3550] = Fluid2D([3417,3415,3439],1); -ELEMENTS[3551] = Fluid2D([3439,3415,3438],1); -ELEMENTS[3552] = Fluid2D([3325,3346,3347],1); -ELEMENTS[3553] = Fluid2D([3347,3346,3371],1); -ELEMENTS[3554] = Fluid2D([3371,3346,3369],1); -ELEMENTS[3555] = Fluid2D([3371,3369,3394],1); -ELEMENTS[3556] = Fluid2D([3437,3413,3412],1); -ELEMENTS[3557] = Fluid2D([3437,3412,3435],1); -ELEMENTS[3558] = Fluid2D([3437,3435,3460],1); -ELEMENTS[3559] = Fluid2D([3460,3435,3458],1); -ELEMENTS[3560] = Fluid2D([3435,3412,3411],1); -ELEMENTS[3561] = Fluid2D([3411,3412,3387],1); -ELEMENTS[3562] = Fluid2D([3458,3435,3434],1); -ELEMENTS[3563] = Fluid2D([3434,3435,3411],1); -ELEMENTS[3564] = Fluid2D([3325,3347,3326],1); -ELEMENTS[3565] = Fluid2D([3326,3347,3350],1); -ELEMENTS[3566] = Fluid2D([3325,3326,3304],1); -ELEMENTS[3567] = Fluid2D([3304,3326,3306],1); -ELEMENTS[3568] = Fluid2D([3306,3326,3330],1); -ELEMENTS[3569] = Fluid2D([3304,3306,3281],1); -ELEMENTS[3570] = Fluid2D([3281,3306,3283],1); -ELEMENTS[3571] = Fluid2D([3283,3306,3307],1); -ELEMENTS[3572] = Fluid2D([3330,3326,3350],1); -ELEMENTS[3573] = Fluid2D([3307,3306,3330],1); -ELEMENTS[3574] = Fluid2D([3307,3330,3331],1); -ELEMENTS[3575] = Fluid2D([3331,3330,3351],1); -ELEMENTS[3576] = Fluid2D([3351,3330,3350],1); -ELEMENTS[3577] = Fluid2D([3331,3351,3353],1); -ELEMENTS[3578] = Fluid2D([3331,3353,3332],1); -ELEMENTS[3579] = Fluid2D([3353,3351,3374],1); -ELEMENTS[3580] = Fluid2D([3374,3351,3373],1); -ELEMENTS[3581] = Fluid2D([3332,3353,3355],1); -ELEMENTS[3582] = Fluid2D([3355,3353,3377],1); -ELEMENTS[3583] = Fluid2D([3377,3353,3374],1); -ELEMENTS[3584] = Fluid2D([3373,3351,3350],1); -ELEMENTS[3585] = Fluid2D([3350,3347,3372],1); -ELEMENTS[3586] = Fluid2D([3372,3347,3371],1); -ELEMENTS[3587] = Fluid2D([3372,3371,3395],1); -ELEMENTS[3588] = Fluid2D([3395,3371,3394],1); -ELEMENTS[3589] = Fluid2D([3395,3394,3418],1); -ELEMENTS[3590] = Fluid2D([3418,3394,3417],1); -ELEMENTS[3591] = Fluid2D([3418,3417,3441],1); -ELEMENTS[3592] = Fluid2D([3441,3417,3439],1); -ELEMENTS[3593] = Fluid2D([3441,3439,3463],1); -ELEMENTS[3594] = Fluid2D([3463,3439,3462],1); -ELEMENTS[3595] = Fluid2D([3462,3439,3438],1); -ELEMENTS[3596] = Fluid2D([3350,3372,3373],1); -ELEMENTS[3597] = Fluid2D([3373,3372,3396],1); -ELEMENTS[3598] = Fluid2D([3396,3372,3395],1); -ELEMENTS[3599] = Fluid2D([3396,3395,3419],1); -ELEMENTS[3600] = Fluid2D([3419,3395,3418],1); -ELEMENTS[3601] = Fluid2D([3419,3418,3442],1); -ELEMENTS[3602] = Fluid2D([3442,3418,3441],1); -ELEMENTS[3603] = Fluid2D([3442,3441,3465],1); -ELEMENTS[3604] = Fluid2D([3465,3441,3463],1); -ELEMENTS[3605] = Fluid2D([3465,3463,3487],1); -ELEMENTS[3606] = Fluid2D([3487,3463,3486],1); -ELEMENTS[3607] = Fluid2D([3465,3487,3489],1); -ELEMENTS[3608] = Fluid2D([3489,3487,3511],1); -ELEMENTS[3609] = Fluid2D([3511,3487,3509],1); -ELEMENTS[3610] = Fluid2D([3373,3396,3397],1); -ELEMENTS[3611] = Fluid2D([3397,3396,3420],1); -ELEMENTS[3612] = Fluid2D([3420,3396,3419],1); -ELEMENTS[3613] = Fluid2D([3420,3419,3443],1); -ELEMENTS[3614] = Fluid2D([3443,3419,3442],1); -ELEMENTS[3615] = Fluid2D([3443,3442,3466],1); -ELEMENTS[3616] = Fluid2D([3466,3442,3465],1); -ELEMENTS[3617] = Fluid2D([3466,3465,3489],1); -ELEMENTS[3618] = Fluid2D([3486,3463,3462],1); -ELEMENTS[3619] = Fluid2D([3486,3462,3484],1); -ELEMENTS[3620] = Fluid2D([3484,3462,3461],1); -ELEMENTS[3621] = Fluid2D([3486,3484,3508],1); -ELEMENTS[3622] = Fluid2D([3461,3462,3438],1); -ELEMENTS[3623] = Fluid2D([3461,3438,3437],1); -ELEMENTS[3624] = Fluid2D([3461,3437,3460],1); -ELEMENTS[3625] = Fluid2D([3508,3484,3507],1); -ELEMENTS[3626] = Fluid2D([3509,3487,3486],1); -ELEMENTS[3627] = Fluid2D([3507,3484,3483],1); -ELEMENTS[3628] = Fluid2D([3483,3484,3461],1); -ELEMENTS[3629] = Fluid2D([3483,3461,3460],1); -ELEMENTS[3630] = Fluid2D([3483,3460,3482],1); -ELEMENTS[3631] = Fluid2D([3483,3482,3506],1); -ELEMENTS[3632] = Fluid2D([3482,3460,3458],1); -ELEMENTS[3633] = Fluid2D([3506,3482,3505],1); -ELEMENTS[3634] = Fluid2D([3482,3458,3481],1); -ELEMENTS[3635] = Fluid2D([3481,3458,3456],1); -ELEMENTS[3636] = Fluid2D([3456,3458,3434],1); -ELEMENTS[3637] = Fluid2D([3456,3434,3433],1); -ELEMENTS[3638] = Fluid2D([3456,3433,3455],1); -ELEMENTS[3639] = Fluid2D([3455,3433,3432],1); -ELEMENTS[3640] = Fluid2D([3432,3433,3408],1); -ELEMENTS[3641] = Fluid2D([3432,3408,3407],1); -ELEMENTS[3642] = Fluid2D([3407,3408,3383],1); -ELEMENTS[3643] = Fluid2D([3383,3408,3385],1); -ELEMENTS[3644] = Fluid2D([3505,3482,3481],1); -ELEMENTS[3645] = Fluid2D([3509,3486,3508],1); -ELEMENTS[3646] = Fluid2D([3509,3508,3532],1); -ELEMENTS[3647] = Fluid2D([3532,3508,3531],1); -ELEMENTS[3648] = Fluid2D([3531,3508,3507],1); -ELEMENTS[3649] = Fluid2D([3531,3507,3530],1); -ELEMENTS[3650] = Fluid2D([3531,3530,3554],1); -ELEMENTS[3651] = Fluid2D([3554,3530,3553],1); -ELEMENTS[3652] = Fluid2D([3553,3530,3529],1); -ELEMENTS[3653] = Fluid2D([3529,3530,3506],1); -ELEMENTS[3654] = Fluid2D([3506,3530,3507],1); -ELEMENTS[3655] = Fluid2D([3506,3507,3483],1); -ELEMENTS[3656] = Fluid2D([3505,3481,3504],1); -ELEMENTS[3657] = Fluid2D([3505,3504,3528],1); -ELEMENTS[3658] = Fluid2D([3528,3504,3526],1); -ELEMENTS[3659] = Fluid2D([3526,3504,3502],1); -ELEMENTS[3660] = Fluid2D([3502,3504,3480],1); -ELEMENTS[3661] = Fluid2D([3480,3504,3481],1); -ELEMENTS[3662] = Fluid2D([3480,3481,3456],1); -ELEMENTS[3663] = Fluid2D([3505,3528,3529],1); -ELEMENTS[3664] = Fluid2D([3529,3528,3552],1); -ELEMENTS[3665] = Fluid2D([3529,3552,3553],1); -ELEMENTS[3666] = Fluid2D([3553,3552,3576],1); -ELEMENTS[3667] = Fluid2D([3576,3552,3574],1); -ELEMENTS[3668] = Fluid2D([3552,3528,3550],1); -ELEMENTS[3669] = Fluid2D([3574,3552,3550],1); -ELEMENTS[3670] = Fluid2D([3574,3550,3572],1); -ELEMENTS[3671] = Fluid2D([3572,3550,3548],1); -ELEMENTS[3672] = Fluid2D([3548,3550,3526],1); -ELEMENTS[3673] = Fluid2D([3550,3528,3526],1); -ELEMENTS[3674] = Fluid2D([3480,3456,3455],1); -ELEMENTS[3675] = Fluid2D([3480,3455,3478],1); -ELEMENTS[3676] = Fluid2D([3478,3455,3453],1); -ELEMENTS[3677] = Fluid2D([3480,3478,3502],1); -ELEMENTS[3678] = Fluid2D([3453,3455,3432],1); -ELEMENTS[3679] = Fluid2D([3502,3478,3500],1); -ELEMENTS[3680] = Fluid2D([3502,3500,3524],1); -ELEMENTS[3681] = Fluid2D([3500,3478,3475],1); -ELEMENTS[3682] = Fluid2D([3475,3478,3453],1); -ELEMENTS[3683] = Fluid2D([3524,3500,3522],1); -ELEMENTS[3684] = Fluid2D([3524,3522,3546],1); -ELEMENTS[3685] = Fluid2D([3522,3500,3498],1); -ELEMENTS[3686] = Fluid2D([3498,3500,3475],1); -ELEMENTS[3687] = Fluid2D([3498,3475,3473],1); -ELEMENTS[3688] = Fluid2D([3473,3475,3451],1); -ELEMENTS[3689] = Fluid2D([3546,3522,3544],1); -ELEMENTS[3690] = Fluid2D([3544,3522,3520],1); -ELEMENTS[3691] = Fluid2D([3520,3522,3498],1); -ELEMENTS[3692] = Fluid2D([3451,3475,3453],1); -ELEMENTS[3693] = Fluid2D([3451,3453,3430],1); -ELEMENTS[3694] = Fluid2D([3430,3453,3432],1); -ELEMENTS[3695] = Fluid2D([3430,3432,3407],1); -ELEMENTS[3696] = Fluid2D([3430,3407,3406],1); -ELEMENTS[3697] = Fluid2D([3406,3407,3382],1); -ELEMENTS[3698] = Fluid2D([3382,3407,3383],1); -ELEMENTS[3699] = Fluid2D([3430,3406,3428],1); -ELEMENTS[3700] = Fluid2D([3430,3428,3451],1); -ELEMENTS[3701] = Fluid2D([3428,3406,3404],1); -ELEMENTS[3702] = Fluid2D([3404,3406,3381],1); -ELEMENTS[3703] = Fluid2D([3428,3404,3427],1); -ELEMENTS[3704] = Fluid2D([3381,3406,3382],1); -ELEMENTS[3705] = Fluid2D([3381,3382,3356],1); -ELEMENTS[3706] = Fluid2D([3381,3356,3354],1); -ELEMENTS[3707] = Fluid2D([3354,3356,3320],1); -ELEMENTS[3708] = Fluid2D([3427,3404,3405],1); -ELEMENTS[3709] = Fluid2D([3405,3404,3380],1); -ELEMENTS[3710] = Fluid2D([3427,3405,3429],1); -ELEMENTS[3711] = Fluid2D([3380,3404,3381],1); -ELEMENTS[3712] = Fluid2D([3429,3405,3399],1); -ELEMENTS[3713] = Fluid2D([3399,3405,3376],1); -ELEMENTS[3714] = Fluid2D([3429,3399,3423],1); -ELEMENTS[3715] = Fluid2D([3376,3405,3380],1); -ELEMENTS[3716] = Fluid2D([3376,3380,3352],1); -ELEMENTS[3717] = Fluid2D([3352,3380,3354],1); -ELEMENTS[3718] = Fluid2D([3354,3380,3381],1); -ELEMENTS[3719] = Fluid2D([3423,3399,3392],1); -ELEMENTS[3720] = Fluid2D([3451,3428,3449],1); -ELEMENTS[3721] = Fluid2D([3451,3449,3473],1); -ELEMENTS[3722] = Fluid2D([3449,3428,3427],1); -ELEMENTS[3723] = Fluid2D([3473,3449,3472],1); -ELEMENTS[3724] = Fluid2D([3472,3449,3450],1); -ELEMENTS[3725] = Fluid2D([3450,3449,3427],1); -ELEMENTS[3726] = Fluid2D([3472,3450,3474],1); -ELEMENTS[3727] = Fluid2D([3472,3474,3497],1); -ELEMENTS[3728] = Fluid2D([3497,3474,3499],1); -ELEMENTS[3729] = Fluid2D([3499,3474,3476],1); -ELEMENTS[3730] = Fluid2D([3476,3474,3452],1); -ELEMENTS[3731] = Fluid2D([3452,3474,3450],1); -ELEMENTS[3732] = Fluid2D([3452,3450,3429],1); -ELEMENTS[3733] = Fluid2D([3450,3427,3429],1); -ELEMENTS[3734] = Fluid2D([3452,3429,3423],1); -ELEMENTS[3735] = Fluid2D([3452,3423,3454],1); -ELEMENTS[3736] = Fluid2D([3452,3454,3476],1); -ELEMENTS[3737] = Fluid2D([3454,3423,3416],1); -ELEMENTS[3738] = Fluid2D([3476,3454,3479],1); -ELEMENTS[3739] = Fluid2D([3479,3454,3440],1); -ELEMENTS[3740] = Fluid2D([3476,3479,3501],1); -ELEMENTS[3741] = Fluid2D([3476,3501,3499],1); -ELEMENTS[3742] = Fluid2D([3501,3479,3503],1); -ELEMENTS[3743] = Fluid2D([3501,3503,3525],1); -ELEMENTS[3744] = Fluid2D([3525,3503,3527],1); -ELEMENTS[3745] = Fluid2D([3527,3503,3488],1); -ELEMENTS[3746] = Fluid2D([3503,3479,3464],1); -ELEMENTS[3747] = Fluid2D([3499,3501,3523],1); -ELEMENTS[3748] = Fluid2D([3499,3523,3521],1); -ELEMENTS[3749] = Fluid2D([3499,3521,3497],1); -ELEMENTS[3750] = Fluid2D([3521,3523,3545],1); -ELEMENTS[3751] = Fluid2D([3545,3523,3547],1); -ELEMENTS[3752] = Fluid2D([3547,3523,3525],1); -ELEMENTS[3753] = Fluid2D([3523,3501,3525],1); -ELEMENTS[3754] = Fluid2D([3497,3521,3519],1); -ELEMENTS[3755] = Fluid2D([3519,3521,3543],1); -ELEMENTS[3756] = Fluid2D([3543,3521,3545],1); -ELEMENTS[3757] = Fluid2D([3519,3543,3542],1); -ELEMENTS[3758] = Fluid2D([3542,3543,3565],1); -ELEMENTS[3759] = Fluid2D([3565,3543,3567],1); -ELEMENTS[3760] = Fluid2D([3567,3543,3545],1); -ELEMENTS[3761] = Fluid2D([3567,3545,3569],1); -ELEMENTS[3762] = Fluid2D([3567,3569,3591],1); -ELEMENTS[3763] = Fluid2D([3591,3569,3593],1); -ELEMENTS[3764] = Fluid2D([3569,3545,3547],1); -ELEMENTS[3765] = Fluid2D([3593,3569,3571],1); -ELEMENTS[3766] = Fluid2D([3571,3569,3547],1); -ELEMENTS[3767] = Fluid2D([3497,3519,3496],1); -ELEMENTS[3768] = Fluid2D([3496,3519,3520],1); -ELEMENTS[3769] = Fluid2D([3497,3496,3472],1); -ELEMENTS[3770] = Fluid2D([3472,3496,3473],1); -ELEMENTS[3771] = Fluid2D([3571,3547,3549],1); -ELEMENTS[3772] = Fluid2D([3549,3547,3525],1); -ELEMENTS[3773] = Fluid2D([3549,3525,3527],1); -ELEMENTS[3774] = Fluid2D([3571,3549,3573],1); -ELEMENTS[3775] = Fluid2D([3573,3549,3551],1); -ELEMENTS[3776] = Fluid2D([3551,3549,3527],1); -ELEMENTS[3777] = Fluid2D([3551,3527,3510],1); -ELEMENTS[3778] = Fluid2D([3520,3519,3542],1); -ELEMENTS[3779] = Fluid2D([3520,3542,3544],1); -ELEMENTS[3780] = Fluid2D([3544,3542,3566],1); -ELEMENTS[3781] = Fluid2D([3566,3542,3565],1); -ELEMENTS[3782] = Fluid2D([3544,3566,3568],1); -ELEMENTS[3783] = Fluid2D([3568,3566,3590],1); -ELEMENTS[3784] = Fluid2D([3590,3566,3588],1); -ELEMENTS[3785] = Fluid2D([3588,3566,3565],1); -ELEMENTS[3786] = Fluid2D([3588,3565,3589],1); -ELEMENTS[3787] = Fluid2D([3588,3589,3610],1); -ELEMENTS[3788] = Fluid2D([3610,3589,3612],1); -ELEMENTS[3789] = Fluid2D([3589,3565,3567],1); -ELEMENTS[3790] = Fluid2D([3588,3610,3611],1); -ELEMENTS[3791] = Fluid2D([3588,3611,3590],1); -ELEMENTS[3792] = Fluid2D([3590,3611,3613],1); -ELEMENTS[3793] = Fluid2D([3613,3611,3636],1); -ELEMENTS[3794] = Fluid2D([3636,3611,3634],1); -ELEMENTS[3795] = Fluid2D([3611,3610,3634],1); -ELEMENTS[3796] = Fluid2D([3634,3610,3635],1); -ELEMENTS[3797] = Fluid2D([3635,3610,3612],1); -ELEMENTS[3798] = Fluid2D([3634,3635,3672],1); -ELEMENTS[3799] = Fluid2D([3634,3672,3673],1); -ELEMENTS[3800] = Fluid2D([3672,3635,3674],1); -ELEMENTS[3801] = Fluid2D([3674,3635,3637],1); -ELEMENTS[3802] = Fluid2D([3637,3635,3612],1); -ELEMENTS[3803] = Fluid2D([3637,3612,3614],1); -ELEMENTS[3804] = Fluid2D([3614,3612,3591],1); -ELEMENTS[3805] = Fluid2D([3673,3672,3701],1); -ELEMENTS[3806] = Fluid2D([3701,3672,3702],1); -ELEMENTS[3807] = Fluid2D([3612,3589,3591],1); -ELEMENTS[3808] = Fluid2D([3702,3672,3674],1); -ELEMENTS[3809] = Fluid2D([3702,3674,3704],1); -ELEMENTS[3810] = Fluid2D([3704,3674,3676],1); -ELEMENTS[3811] = Fluid2D([3676,3674,3637],1); -ELEMENTS[3812] = Fluid2D([3702,3704,3732],1); -ELEMENTS[3813] = Fluid2D([3732,3704,3734],1); -ELEMENTS[3814] = Fluid2D([3734,3704,3707],1); -ELEMENTS[3815] = Fluid2D([3707,3704,3676],1); -ELEMENTS[3816] = Fluid2D([3702,3732,3730],1); -ELEMENTS[3817] = Fluid2D([3702,3730,3701],1); -ELEMENTS[3818] = Fluid2D([3730,3732,3758],1); -ELEMENTS[3819] = Fluid2D([3730,3758,3757],1); -ELEMENTS[3820] = Fluid2D([3757,3758,3786],1); -ELEMENTS[3821] = Fluid2D([3786,3758,3794],1); -ELEMENTS[3822] = Fluid2D([3794,3758,3760],1); -ELEMENTS[3823] = Fluid2D([3760,3758,3732],1); -ELEMENTS[3824] = Fluid2D([3701,3730,3731],1); -ELEMENTS[3825] = Fluid2D([3701,3731,3703],1); -ELEMENTS[3826] = Fluid2D([3703,3731,3733],1); -ELEMENTS[3827] = Fluid2D([3733,3731,3759],1); -ELEMENTS[3828] = Fluid2D([3759,3731,3757],1); -ELEMENTS[3829] = Fluid2D([3731,3730,3757],1); -ELEMENTS[3830] = Fluid2D([3591,3589,3567],1); -ELEMENTS[3831] = Fluid2D([3553,3576,3577],1); -ELEMENTS[3832] = Fluid2D([3577,3576,3600],1); -ELEMENTS[3833] = Fluid2D([3577,3600,3601],1); -ELEMENTS[3834] = Fluid2D([3600,3576,3598],1); -ELEMENTS[3835] = Fluid2D([3553,3577,3554],1); -ELEMENTS[3836] = Fluid2D([3554,3577,3578],1); -ELEMENTS[3837] = Fluid2D([3554,3578,3555],1); -ELEMENTS[3838] = Fluid2D([3601,3600,3624],1); -ELEMENTS[3839] = Fluid2D([3624,3600,3622],1); -ELEMENTS[3840] = Fluid2D([3598,3576,3574],1); -ELEMENTS[3841] = Fluid2D([3555,3578,3579],1); -ELEMENTS[3842] = Fluid2D([3579,3578,3602],1); -ELEMENTS[3843] = Fluid2D([3602,3578,3601],1); -ELEMENTS[3844] = Fluid2D([3601,3578,3577],1); -ELEMENTS[3845] = Fluid2D([3622,3600,3598],1); -ELEMENTS[3846] = Fluid2D([3622,3598,3620],1); -ELEMENTS[3847] = Fluid2D([3620,3598,3596],1); -ELEMENTS[3848] = Fluid2D([3596,3598,3574],1); -ELEMENTS[3849] = Fluid2D([3596,3574,3572],1); -ELEMENTS[3850] = Fluid2D([3596,3572,3594],1); -ELEMENTS[3851] = Fluid2D([3594,3572,3570],1); -ELEMENTS[3852] = Fluid2D([3594,3570,3592],1); -ELEMENTS[3853] = Fluid2D([3570,3572,3548],1); -ELEMENTS[3854] = Fluid2D([3592,3570,3568],1); -ELEMENTS[3855] = Fluid2D([3596,3594,3618],1); -ELEMENTS[3856] = Fluid2D([3618,3594,3615],1); -ELEMENTS[3857] = Fluid2D([3615,3594,3592],1); -ELEMENTS[3858] = Fluid2D([3568,3570,3546],1); -ELEMENTS[3859] = Fluid2D([3568,3546,3544],1); -ELEMENTS[3860] = Fluid2D([3546,3570,3548],1); -ELEMENTS[3861] = Fluid2D([3546,3548,3524],1); -ELEMENTS[3862] = Fluid2D([3524,3548,3526],1); -ELEMENTS[3863] = Fluid2D([3592,3568,3590],1); -ELEMENTS[3864] = Fluid2D([3592,3590,3613],1); -ELEMENTS[3865] = Fluid2D([3592,3613,3615],1); -ELEMENTS[3866] = Fluid2D([3615,3613,3638],1); -ELEMENTS[3867] = Fluid2D([3638,3613,3636],1); -ELEMENTS[3868] = Fluid2D([3638,3636,3675],1); -ELEMENTS[3869] = Fluid2D([3675,3636,3673],1); -ELEMENTS[3870] = Fluid2D([3675,3673,3703],1); -ELEMENTS[3871] = Fluid2D([3673,3636,3634],1); -ELEMENTS[3872] = Fluid2D([3703,3673,3701],1); -ELEMENTS[3873] = Fluid2D([3526,3502,3524],1); -ELEMENTS[3874] = Fluid2D([3601,3624,3625],1); -ELEMENTS[3875] = Fluid2D([3625,3624,3647],1); -ELEMENTS[3876] = Fluid2D([3647,3624,3646],1); -ELEMENTS[3877] = Fluid2D([3646,3624,3622],1); -ELEMENTS[3878] = Fluid2D([3601,3625,3602],1); -ELEMENTS[3879] = Fluid2D([3602,3625,3626],1); -ELEMENTS[3880] = Fluid2D([3626,3625,3652],1); -ELEMENTS[3881] = Fluid2D([3652,3625,3647],1); -ELEMENTS[3882] = Fluid2D([3626,3652,3655],1); -ELEMENTS[3883] = Fluid2D([3655,3652,3690],1); -ELEMENTS[3884] = Fluid2D([3626,3655,3627],1); -ELEMENTS[3885] = Fluid2D([3690,3652,3688],1); -ELEMENTS[3886] = Fluid2D([3627,3655,3658],1); -ELEMENTS[3887] = Fluid2D([3658,3655,3691],1); -ELEMENTS[3888] = Fluid2D([3627,3658,3628],1); -ELEMENTS[3889] = Fluid2D([3691,3655,3690],1); -ELEMENTS[3890] = Fluid2D([3688,3652,3647],1); -ELEMENTS[3891] = Fluid2D([3688,3647,3686],1); -ELEMENTS[3892] = Fluid2D([3686,3647,3646],1); -ELEMENTS[3893] = Fluid2D([3686,3646,3684],1); -ELEMENTS[3894] = Fluid2D([3684,3646,3644],1); -ELEMENTS[3895] = Fluid2D([3684,3644,3681],1); -ELEMENTS[3896] = Fluid2D([3681,3644,3642],1); -ELEMENTS[3897] = Fluid2D([3644,3646,3622],1); -ELEMENTS[3898] = Fluid2D([3642,3644,3620],1); -ELEMENTS[3899] = Fluid2D([3642,3620,3618],1); -ELEMENTS[3900] = Fluid2D([3620,3644,3622],1); -ELEMENTS[3901] = Fluid2D([3628,3658,3660],1); -ELEMENTS[3902] = Fluid2D([3660,3658,3693],1); -ELEMENTS[3903] = Fluid2D([3628,3660,3630],1); -ELEMENTS[3904] = Fluid2D([3693,3658,3691],1); -ELEMENTS[3905] = Fluid2D([3693,3691,3722],1); -ELEMENTS[3906] = Fluid2D([3722,3691,3720],1); -ELEMENTS[3907] = Fluid2D([3720,3691,3690],1); -ELEMENTS[3908] = Fluid2D([3630,3660,3663],1); -ELEMENTS[3909] = Fluid2D([3663,3660,3695],1); -ELEMENTS[3910] = Fluid2D([3695,3660,3693],1); -ELEMENTS[3911] = Fluid2D([3695,3693,3723],1); -ELEMENTS[3912] = Fluid2D([3723,3693,3722],1); -ELEMENTS[3913] = Fluid2D([3723,3722,3748],1); -ELEMENTS[3914] = Fluid2D([3748,3722,3747],1); -ELEMENTS[3915] = Fluid2D([3747,3722,3720],1); -ELEMENTS[3916] = Fluid2D([3630,3663,3631],1); -ELEMENTS[3917] = Fluid2D([3630,3631,3607],1); -ELEMENTS[3918] = Fluid2D([3607,3631,3608],1); -ELEMENTS[3919] = Fluid2D([3631,3663,3666],1); -ELEMENTS[3920] = Fluid2D([3666,3663,3697],1); -ELEMENTS[3921] = Fluid2D([3608,3631,3632],1); -ELEMENTS[3922] = Fluid2D([3632,3631,3666],1); -ELEMENTS[3923] = Fluid2D([3618,3620,3596],1); -ELEMENTS[3924] = Fluid2D([3697,3663,3695],1); -ELEMENTS[3925] = Fluid2D([3686,3684,3715],1); -ELEMENTS[3926] = Fluid2D([3715,3684,3713],1); -ELEMENTS[3927] = Fluid2D([3715,3713,3741],1); -ELEMENTS[3928] = Fluid2D([3741,3713,3740],1); -ELEMENTS[3929] = Fluid2D([3740,3713,3711],1); -ELEMENTS[3930] = Fluid2D([3741,3740,3769],1); -ELEMENTS[3931] = Fluid2D([3769,3740,3766],1); -ELEMENTS[3932] = Fluid2D([3766,3740,3738],1); -ELEMENTS[3933] = Fluid2D([3711,3713,3681],1); -ELEMENTS[3934] = Fluid2D([3738,3740,3711],1); -ELEMENTS[3935] = Fluid2D([3738,3711,3708],1); -ELEMENTS[3936] = Fluid2D([3708,3711,3679],1); -ELEMENTS[3937] = Fluid2D([3679,3711,3681],1); -ELEMENTS[3938] = Fluid2D([3713,3684,3681],1); -ELEMENTS[3939] = Fluid2D([3741,3769,3770],1); -ELEMENTS[3940] = Fluid2D([3741,3770,3743],1); -ELEMENTS[3941] = Fluid2D([3743,3770,3771],1); -ELEMENTS[3942] = Fluid2D([3741,3743,3715],1); -ELEMENTS[3943] = Fluid2D([3715,3743,3717],1); -ELEMENTS[3944] = Fluid2D([3717,3743,3744],1); -ELEMENTS[3945] = Fluid2D([3771,3770,3797],1); -ELEMENTS[3946] = Fluid2D([3797,3770,3796],1); -ELEMENTS[3947] = Fluid2D([3796,3770,3769],1); -ELEMENTS[3948] = Fluid2D([3796,3769,3795],1); -ELEMENTS[3949] = Fluid2D([3744,3743,3771],1); -ELEMENTS[3950] = Fluid2D([3796,3795,3817],1); -ELEMENTS[3951] = Fluid2D([3817,3795,3816],1); -ELEMENTS[3952] = Fluid2D([3816,3795,3792],1); -ELEMENTS[3953] = Fluid2D([3792,3795,3766],1); -ELEMENTS[3954] = Fluid2D([3795,3769,3766],1); -ELEMENTS[3955] = Fluid2D([3796,3817,3819],1); -ELEMENTS[3956] = Fluid2D([3796,3819,3797],1); -ELEMENTS[3957] = Fluid2D([3797,3819,3821],1); -ELEMENTS[3958] = Fluid2D([3821,3819,3845],1); -ELEMENTS[3959] = Fluid2D([3797,3821,3798],1); -ELEMENTS[3960] = Fluid2D([3798,3821,3822],1); -ELEMENTS[3961] = Fluid2D([3822,3821,3846],1); -ELEMENTS[3962] = Fluid2D([3846,3821,3845],1); -ELEMENTS[3963] = Fluid2D([3846,3845,3870],1); -ELEMENTS[3964] = Fluid2D([3870,3845,3869],1); -ELEMENTS[3965] = Fluid2D([3869,3845,3844],1); -ELEMENTS[3966] = Fluid2D([3844,3845,3819],1); -ELEMENTS[3967] = Fluid2D([3819,3817,3844],1); -ELEMENTS[3968] = Fluid2D([3844,3817,3841],1); -ELEMENTS[3969] = Fluid2D([3844,3841,3867],1); -ELEMENTS[3970] = Fluid2D([3844,3867,3869],1); -ELEMENTS[3971] = Fluid2D([3867,3841,3866],1); -ELEMENTS[3972] = Fluid2D([3841,3817,3816],1); -ELEMENTS[3973] = Fluid2D([3841,3816,3839],1); -ELEMENTS[3974] = Fluid2D([3839,3816,3815],1); -ELEMENTS[3975] = Fluid2D([3815,3816,3792],1); -ELEMENTS[3976] = Fluid2D([3866,3841,3839],1); -ELEMENTS[3977] = Fluid2D([3866,3839,3864],1); -ELEMENTS[3978] = Fluid2D([3864,3839,3838],1); -ELEMENTS[3979] = Fluid2D([3838,3839,3815],1); -ELEMENTS[3980] = Fluid2D([3864,3838,3865],1); -ELEMENTS[3981] = Fluid2D([3865,3838,3837],1); -ELEMENTS[3982] = Fluid2D([3837,3838,3814],1); -ELEMENTS[3983] = Fluid2D([3814,3838,3815],1); -ELEMENTS[3984] = Fluid2D([3814,3815,3790],1); -ELEMENTS[3985] = Fluid2D([3790,3815,3792],1); -ELEMENTS[3986] = Fluid2D([3790,3792,3763],1); -ELEMENTS[3987] = Fluid2D([3763,3792,3766],1); -ELEMENTS[3988] = Fluid2D([3814,3790,3788],1); -ELEMENTS[3989] = Fluid2D([3788,3790,3761],1); -ELEMENTS[3990] = Fluid2D([3814,3788,3813],1); -ELEMENTS[3991] = Fluid2D([3813,3788,3787],1); -ELEMENTS[3992] = Fluid2D([3787,3788,3759],1); -ELEMENTS[3993] = Fluid2D([3761,3790,3763],1); -ELEMENTS[3994] = Fluid2D([3761,3763,3736],1); -ELEMENTS[3995] = Fluid2D([3736,3763,3738],1); -ELEMENTS[3996] = Fluid2D([3738,3763,3766],1); -ELEMENTS[3997] = Fluid2D([3869,3867,3890],1); -ELEMENTS[3998] = Fluid2D([3890,3867,3889],1); -ELEMENTS[3999] = Fluid2D([3889,3867,3866],1); -ELEMENTS[4000] = Fluid2D([3869,3890,3892],1); -ELEMENTS[4001] = Fluid2D([3892,3890,3916],1); -ELEMENTS[4002] = Fluid2D([3916,3890,3918],1); -ELEMENTS[4003] = Fluid2D([3869,3892,3870],1); -ELEMENTS[4004] = Fluid2D([3870,3892,3894],1); -ELEMENTS[4005] = Fluid2D([3870,3894,3873],1); -ELEMENTS[4006] = Fluid2D([3873,3894,3898],1); -ELEMENTS[4007] = Fluid2D([3898,3894,3919],1); -ELEMENTS[4008] = Fluid2D([3919,3894,3917],1); -ELEMENTS[4009] = Fluid2D([3873,3898,3874],1); -ELEMENTS[4010] = Fluid2D([3919,3917,3945],1); -ELEMENTS[4011] = Fluid2D([3894,3892,3917],1); -ELEMENTS[4012] = Fluid2D([3917,3892,3916],1); -ELEMENTS[4013] = Fluid2D([3917,3916,3942],1); -ELEMENTS[4014] = Fluid2D([3942,3916,3943],1); -ELEMENTS[4015] = Fluid2D([3759,3788,3761],1); -ELEMENTS[4016] = Fluid2D([3759,3761,3733],1); -ELEMENTS[4017] = Fluid2D([3733,3761,3736],1); -ELEMENTS[4018] = Fluid2D([3733,3736,3706],1); -ELEMENTS[4019] = Fluid2D([3733,3706,3703],1); -ELEMENTS[4020] = Fluid2D([3706,3736,3708],1); -ELEMENTS[4021] = Fluid2D([3708,3736,3738],1); -ELEMENTS[4022] = Fluid2D([3703,3706,3675],1); -ELEMENTS[4023] = Fluid2D([3945,3917,3942],1); -ELEMENTS[4024] = Fluid2D([3945,3942,3968],1); -ELEMENTS[4025] = Fluid2D([3968,3942,3973],1); -ELEMENTS[4026] = Fluid2D([3717,3744,3718],1); -ELEMENTS[4027] = Fluid2D([3717,3718,3688],1); -ELEMENTS[4028] = Fluid2D([3688,3718,3690],1); -ELEMENTS[4029] = Fluid2D([3690,3718,3720],1); -ELEMENTS[4030] = Fluid2D([3720,3718,3746],1); -ELEMENTS[4031] = Fluid2D([3718,3744,3746],1); -ELEMENTS[4032] = Fluid2D([3746,3744,3772],1); -ELEMENTS[4033] = Fluid2D([3746,3772,3775],1); -ELEMENTS[4034] = Fluid2D([3775,3772,3800],1); -ELEMENTS[4035] = Fluid2D([3800,3772,3798],1); -ELEMENTS[4036] = Fluid2D([3798,3772,3771],1); -ELEMENTS[4037] = Fluid2D([3771,3772,3744],1); -ELEMENTS[4038] = Fluid2D([3720,3746,3747],1); -ELEMENTS[4039] = Fluid2D([3775,3800,3801],1); -ELEMENTS[4040] = Fluid2D([3801,3800,3825],1); -ELEMENTS[4041] = Fluid2D([3825,3800,3822],1); -ELEMENTS[4042] = Fluid2D([3822,3800,3798],1); -ELEMENTS[4043] = Fluid2D([3775,3801,3776],1); -ELEMENTS[4044] = Fluid2D([3775,3776,3747],1); -ELEMENTS[4045] = Fluid2D([3747,3776,3748],1); -ELEMENTS[4046] = Fluid2D([3748,3776,3777],1); -ELEMENTS[4047] = Fluid2D([3777,3776,3803],1); -ELEMENTS[4048] = Fluid2D([3803,3776,3801],1); -ELEMENTS[4049] = Fluid2D([3803,3801,3826],1); -ELEMENTS[4050] = Fluid2D([3826,3801,3825],1); -ELEMENTS[4051] = Fluid2D([3826,3825,3851],1); -ELEMENTS[4052] = Fluid2D([3851,3825,3847],1); -ELEMENTS[4053] = Fluid2D([3748,3777,3751],1); -ELEMENTS[4054] = Fluid2D([3748,3751,3723],1); -ELEMENTS[4055] = Fluid2D([3851,3847,3874],1); -ELEMENTS[4056] = Fluid2D([3847,3825,3822],1); -ELEMENTS[4057] = Fluid2D([3723,3751,3725],1); -ELEMENTS[4058] = Fluid2D([3723,3725,3695],1); -ELEMENTS[4059] = Fluid2D([3695,3725,3697],1); -ELEMENTS[4060] = Fluid2D([3874,3847,3873],1); -ELEMENTS[4061] = Fluid2D([3873,3847,3846],1); -ELEMENTS[4062] = Fluid2D([3846,3847,3822],1); -ELEMENTS[4063] = Fluid2D([3873,3846,3870],1); -ELEMENTS[4064] = Fluid2D([3798,3771,3797],1); -ELEMENTS[4065] = Fluid2D([3258,3236,3233],1); -ELEMENTS[4066] = Fluid2D([3258,3233,3255],1); -ELEMENTS[4067] = Fluid2D([2908,2886,2882],1); -ELEMENTS[4068] = Fluid2D([2579,2549,2573],1); -ELEMENTS[4069] = Fluid2D([2573,2549,2552],1); -ELEMENTS[4070] = Fluid2D([2579,2573,2603],1); -ELEMENTS[4071] = Fluid2D([2603,2573,2600],1); -ELEMENTS[4072] = Fluid2D([2600,2573,2577],1); -ELEMENTS[4073] = Fluid2D([2603,2600,2627],1); -ELEMENTS[4074] = Fluid2D([2627,2600,2623],1); -ELEMENTS[4075] = Fluid2D([2623,2600,2601],1); -ELEMENTS[4076] = Fluid2D([2627,2623,2652],1); -ELEMENTS[4077] = Fluid2D([2627,2652,2654],1); -ELEMENTS[4078] = Fluid2D([2654,2652,2679],1); -ELEMENTS[4079] = Fluid2D([2654,2679,2682],1); -ELEMENTS[4080] = Fluid2D([2682,2679,2706],1); -ELEMENTS[4081] = Fluid2D([2682,2706,2709],1); -ELEMENTS[4082] = Fluid2D([2709,2706,2733],1); -ELEMENTS[4083] = Fluid2D([2733,2706,2730],1); -ELEMENTS[4084] = Fluid2D([2730,2706,2703],1); -ELEMENTS[4085] = Fluid2D([2652,2623,2645],1); -ELEMENTS[4086] = Fluid2D([2645,2623,2601],1); -ELEMENTS[4087] = Fluid2D([2733,2730,2756],1); -ELEMENTS[4088] = Fluid2D([2733,2756,2759],1); -ELEMENTS[4089] = Fluid2D([2759,2756,2782],1); -ELEMENTS[4090] = Fluid2D([2730,2703,2726],1); -ELEMENTS[4091] = Fluid2D([2726,2703,2699],1); -ELEMENTS[4092] = Fluid2D([2699,2703,2675],1); -ELEMENTS[4093] = Fluid2D([2675,2703,2679],1); -ELEMENTS[4094] = Fluid2D([2679,2703,2706],1); -ELEMENTS[4095] = Fluid2D([2759,2782,2785],1); -ELEMENTS[4096] = Fluid2D([2756,2730,2753],1); -ELEMENTS[4097] = Fluid2D([2753,2730,2726],1); -ELEMENTS[4098] = Fluid2D([2699,2675,2672],1); -ELEMENTS[4099] = Fluid2D([2699,2672,2694],1); -ELEMENTS[4100] = Fluid2D([2694,2672,2650],1); -ELEMENTS[4101] = Fluid2D([2672,2675,2645],1); -ELEMENTS[4102] = Fluid2D([2672,2645,2650],1); -ELEMENTS[4103] = Fluid2D([2645,2675,2652],1); -ELEMENTS[4104] = Fluid2D([2652,2675,2679],1); -ELEMENTS[4105] = Fluid2D([3284,3309,3314],1); -ELEMENTS[4106] = Fluid2D([2783,2755,2778],1); -ELEMENTS[4107] = Fluid2D([2770,2749,2742],1); -ELEMENTS[4108] = Fluid2D([3376,3352,3343],1); -ELEMENTS[4109] = Fluid2D([2405,2429,2454],1); -ELEMENTS[4110] = Fluid2D([3632,3609,3608],1); -ELEMENTS[4111] = Fluid2D([3608,3609,3585],1); -ELEMENTS[4112] = Fluid2D([3608,3585,3584],1); -ELEMENTS[4113] = Fluid2D([3585,3609,3586],1); -ELEMENTS[4114] = Fluid2D([3585,3586,3562],1); -ELEMENTS[4115] = Fluid2D([3585,3562,3561],1); -ELEMENTS[4116] = Fluid2D([3562,3586,3564],1); -ELEMENTS[4117] = Fluid2D([3562,3564,3540],1); -ELEMENTS[4118] = Fluid2D([3540,3564,3541],1); -ELEMENTS[4119] = Fluid2D([3540,3541,3517],1); -ELEMENTS[4120] = Fluid2D([3517,3541,3518],1); -ELEMENTS[4121] = Fluid2D([3517,3518,3494],1); -ELEMENTS[4122] = Fluid2D([3540,3517,3516],1); -ELEMENTS[4123] = Fluid2D([3494,3518,3495],1); -ELEMENTS[4124] = Fluid2D([3494,3495,3471],1); -ELEMENTS[4125] = Fluid2D([3584,3585,3561],1); -ELEMENTS[4126] = Fluid2D([3471,3495,3477],1); -ELEMENTS[4127] = Fluid2D([3471,3477,3448],1); -ELEMENTS[4128] = Fluid2D([3540,3516,3539],1); -ELEMENTS[4129] = Fluid2D([3448,3477,3457],1); -ELEMENTS[4130] = Fluid2D([3471,3448,3447],1); -ELEMENTS[4131] = Fluid2D([3539,3516,3515],1); -ELEMENTS[4132] = Fluid2D([3515,3516,3492],1); -ELEMENTS[4133] = Fluid2D([3471,3447,3470],1); -ELEMENTS[4134] = Fluid2D([3447,3448,3425],1); -ELEMENTS[4135] = Fluid2D([3492,3516,3493],1); -ELEMENTS[4136] = Fluid2D([3425,3448,3431],1); -ELEMENTS[4137] = Fluid2D([3470,3447,3446],1); -ELEMENTS[4138] = Fluid2D([3446,3447,3424],1); -ELEMENTS[4139] = Fluid2D([3424,3447,3425],1); -ELEMENTS[4140] = Fluid2D([3493,3516,3517],1); -ELEMENTS[4141] = Fluid2D([3431,3448,3457],1); -ELEMENTS[4142] = Fluid2D([3431,3457,3436],1); -ELEMENTS[4143] = Fluid2D([3431,3436,3410],1); -ELEMENTS[4144] = Fluid2D([3410,3436,3414],1); -ELEMENTS[4145] = Fluid2D([3431,3410,3403],1); -ELEMENTS[4146] = Fluid2D([3403,3410,3384],1); -ELEMENTS[4147] = Fluid2D([3384,3410,3388],1); -ELEMENTS[4148] = Fluid2D([3388,3410,3414],1); -ELEMENTS[4149] = Fluid2D([3388,3414,3393],1); -ELEMENTS[4150] = Fluid2D([3388,3393,3366],1); -ELEMENTS[4151] = Fluid2D([3388,3366,3363],1); -ELEMENTS[4152] = Fluid2D([3363,3366,3341],1); -ELEMENTS[4153] = Fluid2D([3341,3366,3345],1); -ELEMENTS[4154] = Fluid2D([3345,3366,3370],1); -ELEMENTS[4155] = Fluid2D([3366,3393,3370],1); -ELEMENTS[4156] = Fluid2D([3493,3517,3494],1); -ELEMENTS[4157] = Fluid2D([3493,3494,3470],1); -ELEMENTS[4158] = Fluid2D([3493,3470,3469],1); -ELEMENTS[4159] = Fluid2D([3469,3470,3446],1); -ELEMENTS[4160] = Fluid2D([3493,3469,3492],1); -ELEMENTS[4161] = Fluid2D([3492,3469,3468],1); -ELEMENTS[4162] = Fluid2D([3468,3469,3445],1); -ELEMENTS[4163] = Fluid2D([3468,3445,3444],1); -ELEMENTS[4164] = Fluid2D([3445,3469,3446],1); -ELEMENTS[4165] = Fluid2D([3445,3446,3422],1); -ELEMENTS[4166] = Fluid2D([3422,3446,3424],1); -ELEMENTS[4167] = Fluid2D([3444,3445,3421],1); -ELEMENTS[4168] = Fluid2D([3444,3421,3420],1); -ELEMENTS[4169] = Fluid2D([3420,3421,3397],1); -ELEMENTS[4170] = Fluid2D([3421,3445,3422],1); -ELEMENTS[4171] = Fluid2D([3470,3494,3471],1); -ELEMENTS[4172] = Fluid2D([3397,3421,3398],1); -ELEMENTS[4173] = Fluid2D([3397,3398,3374],1); -ELEMENTS[4174] = Fluid2D([3398,3421,3422],1); -ELEMENTS[4175] = Fluid2D([3398,3422,3400],1); -ELEMENTS[4176] = Fluid2D([3400,3422,3424],1); -ELEMENTS[4177] = Fluid2D([3400,3424,3402],1); -ELEMENTS[4178] = Fluid2D([3402,3424,3425],1); -ELEMENTS[4179] = Fluid2D([3402,3425,3403],1); -ELEMENTS[4180] = Fluid2D([3402,3403,3379],1); -ELEMENTS[4181] = Fluid2D([3379,3403,3384],1); -ELEMENTS[4182] = Fluid2D([3403,3425,3431],1); -ELEMENTS[4183] = Fluid2D([3379,3384,3359],1); -ELEMENTS[4184] = Fluid2D([3359,3384,3363],1); -ELEMENTS[4185] = Fluid2D([3363,3384,3388],1); -ELEMENTS[4186] = Fluid2D([3379,3359,3358],1); -ELEMENTS[4187] = Fluid2D([3358,3359,3336],1); -ELEMENTS[4188] = Fluid2D([3336,3359,3337],1); -ELEMENTS[4189] = Fluid2D([3337,3359,3363],1); -ELEMENTS[4190] = Fluid2D([3379,3358,3378],1); -ELEMENTS[4191] = Fluid2D([3378,3358,3355],1); -ELEMENTS[4192] = Fluid2D([3355,3358,3335],1); -ELEMENTS[4193] = Fluid2D([3335,3358,3336],1); -ELEMENTS[4194] = Fluid2D([3337,3363,3341],1); -ELEMENTS[4195] = Fluid2D([3337,3341,3315],1); -ELEMENTS[4196] = Fluid2D([3337,3315,3313],1); -ELEMENTS[4197] = Fluid2D([3313,3315,3290],1); -ELEMENTS[4198] = Fluid2D([3290,3315,3293],1); -ELEMENTS[4199] = Fluid2D([3315,3341,3318],1); -ELEMENTS[4200] = Fluid2D([3318,3341,3345],1); -ELEMENTS[4201] = Fluid2D([3318,3345,3324],1); -ELEMENTS[4202] = Fluid2D([3324,3345,3348],1); -ELEMENTS[4203] = Fluid2D([3324,3348,3328],1); -ELEMENTS[4204] = Fluid2D([3293,3315,3318],1); -ELEMENTS[4205] = Fluid2D([3374,3398,3377],1); -ELEMENTS[4206] = Fluid2D([3377,3398,3400],1); -ELEMENTS[4207] = Fluid2D([3377,3400,3378],1); -ELEMENTS[4208] = Fluid2D([3378,3400,3402],1); -ELEMENTS[4209] = Fluid2D([3378,3402,3379],1); -ELEMENTS[4210] = Fluid2D([3584,3561,3560],1); -ELEMENTS[4211] = Fluid2D([3560,3561,3537],1); -ELEMENTS[4212] = Fluid2D([3584,3560,3583],1); -ELEMENTS[4213] = Fluid2D([3537,3561,3539],1); -ELEMENTS[4214] = Fluid2D([3539,3561,3562],1); -ELEMENTS[4215] = Fluid2D([3560,3537,3536],1); -ELEMENTS[4216] = Fluid2D([3583,3560,3559],1); -ELEMENTS[4217] = Fluid2D([3560,3536,3559],1); -ELEMENTS[4218] = Fluid2D([3536,3537,3514],1); -ELEMENTS[4219] = Fluid2D([3514,3537,3515],1); -ELEMENTS[4220] = Fluid2D([3515,3537,3539],1); -ELEMENTS[4221] = Fluid2D([3536,3514,3513],1); -ELEMENTS[4222] = Fluid2D([3536,3513,3535],1); -ELEMENTS[4223] = Fluid2D([3513,3514,3490],1); -ELEMENTS[4224] = Fluid2D([3490,3514,3491],1); -ELEMENTS[4225] = Fluid2D([3535,3513,3511],1); -ELEMENTS[4226] = Fluid2D([3491,3514,3515],1); -ELEMENTS[4227] = Fluid2D([3491,3515,3492],1); -ELEMENTS[4228] = Fluid2D([3559,3536,3535],1); -ELEMENTS[4229] = Fluid2D([3559,3535,3557],1); -ELEMENTS[4230] = Fluid2D([3557,3535,3533],1); -ELEMENTS[4231] = Fluid2D([3533,3535,3511],1); -ELEMENTS[4232] = Fluid2D([3557,3533,3556],1); -ELEMENTS[4233] = Fluid2D([3557,3556,3580],1); -ELEMENTS[4234] = Fluid2D([3580,3556,3579],1); -ELEMENTS[4235] = Fluid2D([3556,3533,3532],1); -ELEMENTS[4236] = Fluid2D([3532,3533,3509],1); -ELEMENTS[4237] = Fluid2D([3509,3533,3511],1); -ELEMENTS[4238] = Fluid2D([3511,3513,3489],1); -ELEMENTS[4239] = Fluid2D([3489,3513,3490],1); -ELEMENTS[4240] = Fluid2D([3579,3556,3555],1); -ELEMENTS[4241] = Fluid2D([3555,3556,3532],1); -ELEMENTS[4242] = Fluid2D([3489,3490,3466],1); -ELEMENTS[4243] = Fluid2D([3466,3490,3467],1); -ELEMENTS[4244] = Fluid2D([3467,3490,3491],1); -ELEMENTS[4245] = Fluid2D([3467,3491,3468],1); -ELEMENTS[4246] = Fluid2D([3468,3491,3492],1); -ELEMENTS[4247] = Fluid2D([3467,3468,3444],1); -ELEMENTS[4248] = Fluid2D([3467,3444,3443],1); -ELEMENTS[4249] = Fluid2D([3467,3443,3466],1); -ELEMENTS[4250] = Fluid2D([3443,3444,3420],1); -ELEMENTS[4251] = Fluid2D([3584,3583,3607],1); -ELEMENTS[4252] = Fluid2D([3607,3583,3606],1); -ELEMENTS[4253] = Fluid2D([3606,3583,3581],1); -ELEMENTS[4254] = Fluid2D([3607,3606,3630],1); -ELEMENTS[4255] = Fluid2D([3581,3583,3559],1); -ELEMENTS[4256] = Fluid2D([3581,3559,3557],1); -ELEMENTS[4257] = Fluid2D([3630,3606,3628],1); -ELEMENTS[4258] = Fluid2D([3628,3606,3604],1); -ELEMENTS[4259] = Fluid2D([3628,3604,3627],1); -ELEMENTS[4260] = Fluid2D([3604,3606,3581],1); -ELEMENTS[4261] = Fluid2D([3627,3604,3603],1); -ELEMENTS[4262] = Fluid2D([3603,3604,3580],1); -ELEMENTS[4263] = Fluid2D([3581,3557,3580],1); -ELEMENTS[4264] = Fluid2D([3604,3581,3580],1); -ELEMENTS[4265] = Fluid2D([3540,3539,3562],1); -ELEMENTS[4266] = Fluid2D([3337,3313,3336],1); -ELEMENTS[4267] = Fluid2D([3336,3313,3312],1); -ELEMENTS[4268] = Fluid2D([3336,3312,3335],1); -ELEMENTS[4269] = Fluid2D([3335,3312,3311],1); -ELEMENTS[4270] = Fluid2D([3311,3312,3288],1); -ELEMENTS[4271] = Fluid2D([3335,3311,3332],1); -ELEMENTS[4272] = Fluid2D([3332,3311,3310],1); -ELEMENTS[4273] = Fluid2D([3332,3310,3331],1); -ELEMENTS[4274] = Fluid2D([3331,3310,3307],1); -ELEMENTS[4275] = Fluid2D([3307,3310,3285],1); -ELEMENTS[4276] = Fluid2D([3285,3310,3287],1); -ELEMENTS[4277] = Fluid2D([3311,3288,3287],1); -ELEMENTS[4278] = Fluid2D([3287,3288,3264],1); -ELEMENTS[4279] = Fluid2D([3264,3288,3265],1); -ELEMENTS[4280] = Fluid2D([3265,3288,3289],1); -ELEMENTS[4281] = Fluid2D([3289,3288,3312],1); -ELEMENTS[4282] = Fluid2D([3289,3312,3313],1); -ELEMENTS[4283] = Fluid2D([3289,3313,3290],1); -ELEMENTS[4284] = Fluid2D([3287,3310,3311],1); -ELEMENTS[4285] = Fluid2D([3289,3290,3266],1); -ELEMENTS[4286] = Fluid2D([3266,3290,3268],1); -ELEMENTS[4287] = Fluid2D([3268,3290,3293],1); -ELEMENTS[4288] = Fluid2D([3268,3293,3272],1); -ELEMENTS[4289] = Fluid2D([3289,3266,3265],1); -ELEMENTS[4290] = Fluid2D([3265,3266,3243],1); -ELEMENTS[4291] = Fluid2D([3265,3243,3240],1); -ELEMENTS[4292] = Fluid2D([3265,3240,3264],1); -ELEMENTS[4293] = Fluid2D([3264,3240,3239],1); -ELEMENTS[4294] = Fluid2D([3264,3239,3262],1); -ELEMENTS[4295] = Fluid2D([3264,3262,3287],1); -ELEMENTS[4296] = Fluid2D([3262,3239,3237],1); -ELEMENTS[4297] = Fluid2D([3262,3237,3260],1); -ELEMENTS[4298] = Fluid2D([3260,3237,3235],1); -ELEMENTS[4299] = Fluid2D([3260,3235,3259],1); -ELEMENTS[4300] = Fluid2D([3259,3235,3234],1); -ELEMENTS[4301] = Fluid2D([3234,3235,3211],1); -ELEMENTS[4302] = Fluid2D([3234,3211,3209],1); -ELEMENTS[4303] = Fluid2D([3234,3209,3232],1); -ELEMENTS[4304] = Fluid2D([3232,3209,3208],1); -ELEMENTS[4305] = Fluid2D([3232,3208,3231],1); -ELEMENTS[4306] = Fluid2D([3208,3209,3184],1); -ELEMENTS[4307] = Fluid2D([3287,3262,3285],1); -ELEMENTS[4308] = Fluid2D([3285,3262,3260],1); -ELEMENTS[4309] = Fluid2D([3285,3260,3283],1); -ELEMENTS[4310] = Fluid2D([3283,3260,3259],1); -ELEMENTS[4311] = Fluid2D([3283,3259,3281],1); -ELEMENTS[4312] = Fluid2D([3281,3259,3257],1); -ELEMENTS[4313] = Fluid2D([3257,3259,3234],1); -ELEMENTS[4314] = Fluid2D([3285,3283,3307],1); -ELEMENTS[4315] = Fluid2D([3257,3234,3232],1); -ELEMENTS[4316] = Fluid2D([3257,3232,3256],1); -ELEMENTS[4317] = Fluid2D([3257,3256,3279],1); -ELEMENTS[4318] = Fluid2D([3279,3256,3277],1); -ELEMENTS[4319] = Fluid2D([3279,3277,3303],1); -ELEMENTS[4320] = Fluid2D([3303,3277,3299],1); -ELEMENTS[4321] = Fluid2D([3299,3277,3271],1); -ELEMENTS[4322] = Fluid2D([3256,3232,3231],1); -ELEMENTS[4323] = Fluid2D([3279,3303,3304],1); -ELEMENTS[4324] = Fluid2D([3304,3303,3325],1); -ELEMENTS[4325] = Fluid2D([3281,3257,3279],1); -ELEMENTS[4326] = Fluid2D([3281,3279,3304],1); -ELEMENTS[4327] = Fluid2D([3608,3584,3607],1); -ELEMENTS[4328] = Fluid2D([3335,3332,3355],1); -ELEMENTS[4329] = Fluid2D([3603,3580,3579],1); -ELEMENTS[4330] = Fluid2D([3603,3579,3602],1); -ELEMENTS[4331] = Fluid2D([3603,3602,3626],1); -ELEMENTS[4332] = Fluid2D([3603,3626,3627],1); -ELEMENTS[4333] = Fluid2D([2913,2920,2891],1); -ELEMENTS[4334] = Fluid2D([3997,3977,3967],1); -ELEMENTS[4335] = Fluid2D([3967,3977,3952],1); -ELEMENTS[4336] = Fluid2D([3952,3977,3970],1); -ELEMENTS[4337] = Fluid2D([3970,3977,4000],1); -ELEMENTS[4338] = Fluid2D([3967,3932,3935],1); -ELEMENTS[4339] = Fluid2D([1173,1162,1121],1); -ELEMENTS[4340] = Fluid2D([1121,1162,1088],1); -ELEMENTS[4341] = Fluid2D([3149,3125,3126],1); -ELEMENTS[4342] = Fluid2D([3126,3125,3099],1); -ELEMENTS[4343] = Fluid2D([3149,3126,3153],1); -ELEMENTS[4344] = Fluid2D([3149,3153,3177],1); -ELEMENTS[4345] = Fluid2D([3149,3177,3173],1); -ELEMENTS[4346] = Fluid2D([3153,3126,3133],1); -ELEMENTS[4347] = Fluid2D([3173,3177,3199],1); -ELEMENTS[4348] = Fluid2D([3199,3177,3201],1); -ELEMENTS[4349] = Fluid2D([3099,3125,3104],1); -ELEMENTS[4350] = Fluid2D([3104,3125,3127],1); -ELEMENTS[4351] = Fluid2D([3177,3153,3179],1); -ELEMENTS[4352] = Fluid2D([3126,3099,3110],1); -ELEMENTS[4353] = Fluid2D([2267,2246,2236],1); -ELEMENTS[4354] = Fluid2D([2267,2236,2255],1); -ELEMENTS[4355] = Fluid2D([2255,2236,2222],1); -ELEMENTS[4356] = Fluid2D([2267,2255,2287],1); -ELEMENTS[4357] = Fluid2D([2287,2255,2275],1); -ELEMENTS[4358] = Fluid2D([2287,2275,2308],1); -ELEMENTS[4359] = Fluid2D([2222,2236,2203],1); -ELEMENTS[4360] = Fluid2D([2222,2203,2191],1); -ELEMENTS[4361] = Fluid2D([2308,2275,2296],1); -ELEMENTS[4362] = Fluid2D([2236,2246,2215],1); -ELEMENTS[4363] = Fluid2D([2215,2246,2226],1); -ELEMENTS[4364] = Fluid2D([2215,2226,2195],1); -ELEMENTS[4365] = Fluid2D([2195,2226,2205],1); -ELEMENTS[4366] = Fluid2D([2195,2205,2173],1); -ELEMENTS[4367] = Fluid2D([2191,2203,2170],1); -ELEMENTS[4368] = Fluid2D([2191,2170,2159],1); -ELEMENTS[4369] = Fluid2D([2170,2203,2183],1); -ELEMENTS[4370] = Fluid2D([2183,2203,2215],1); -ELEMENTS[4371] = Fluid2D([2159,2170,2138],1); -ELEMENTS[4372] = Fluid2D([2138,2170,2150],1); -ELEMENTS[4373] = Fluid2D([2150,2170,2183],1); -ELEMENTS[4374] = Fluid2D([2215,2203,2236],1); -ELEMENTS[4375] = Fluid2D([2173,2205,2186],1); -ELEMENTS[4376] = Fluid2D([2173,2186,2153],1); -ELEMENTS[4377] = Fluid2D([2173,2153,2141],1); -ELEMENTS[4378] = Fluid2D([2153,2186,2166],1); -ELEMENTS[4379] = Fluid2D([2153,2166,2133],1); -ELEMENTS[4380] = Fluid2D([2173,2141,2162],1); -ELEMENTS[4381] = Fluid2D([2133,2166,2144],1); -ELEMENTS[4382] = Fluid2D([2133,2144,2112],1); -ELEMENTS[4383] = Fluid2D([2112,2144,2124],1); -ELEMENTS[4384] = Fluid2D([2112,2124,2092],1); -ELEMENTS[4385] = Fluid2D([2092,2124,2102],1); -ELEMENTS[4386] = Fluid2D([2141,2153,2120],1); -ELEMENTS[4387] = Fluid2D([2120,2153,2133],1); -ELEMENTS[4388] = Fluid2D([2120,2133,2099],1); -ELEMENTS[4389] = Fluid2D([2099,2133,2112],1); -ELEMENTS[4390] = Fluid2D([2099,2112,2079],1); -ELEMENTS[4391] = Fluid2D([2079,2112,2092],1); -ELEMENTS[4392] = Fluid2D([2079,2092,2058],1); -ELEMENTS[4393] = Fluid2D([2058,2092,2069],1); -ELEMENTS[4394] = Fluid2D([2058,2069,2037],1); -ELEMENTS[4395] = Fluid2D([2037,2069,2053],1); -ELEMENTS[4396] = Fluid2D([2053,2069,2086],1); -ELEMENTS[4397] = Fluid2D([2086,2069,2102],1); -ELEMENTS[4398] = Fluid2D([2102,2069,2092],1); -ELEMENTS[4399] = Fluid2D([2296,2275,2265],1); -ELEMENTS[4400] = Fluid2D([2265,2275,2243],1); -ELEMENTS[4401] = Fluid2D([2243,2275,2255],1); -ELEMENTS[4402] = Fluid2D([2265,2243,2234],1); -ELEMENTS[4403] = Fluid2D([2234,2243,2212],1); -ELEMENTS[4404] = Fluid2D([2234,2212,2201],1); -ELEMENTS[4405] = Fluid2D([2201,2212,2180],1); -ELEMENTS[4406] = Fluid2D([2180,2212,2191],1); -ELEMENTS[4407] = Fluid2D([2212,2243,2222],1); -ELEMENTS[4408] = Fluid2D([2191,2212,2222],1); -ELEMENTS[4409] = Fluid2D([2222,2243,2255],1); -ELEMENTS[4410] = Fluid2D([2265,2234,2253],1); -ELEMENTS[4411] = Fluid2D([2253,2234,2221],1); -ELEMENTS[4412] = Fluid2D([2253,2221,2245],1); -ELEMENTS[4413] = Fluid2D([2245,2221,2213],1); -ELEMENTS[4414] = Fluid2D([2213,2221,2190],1); -ELEMENTS[4415] = Fluid2D([2190,2221,2201],1); -ELEMENTS[4416] = Fluid2D([2190,2201,2169],1); -ELEMENTS[4417] = Fluid2D([2169,2201,2180],1); -ELEMENTS[4418] = Fluid2D([2221,2234,2201],1); -ELEMENTS[4419] = Fluid2D([2169,2180,2148],1); -ELEMENTS[4420] = Fluid2D([2169,2148,2136],1); -ELEMENTS[4421] = Fluid2D([2136,2148,2116],1); -ELEMENTS[4422] = Fluid2D([2116,2148,2126],1); -ELEMENTS[4423] = Fluid2D([2126,2148,2159],1); -ELEMENTS[4424] = Fluid2D([2169,2136,2158],1); -ELEMENTS[4425] = Fluid2D([2158,2136,2127],1); -ELEMENTS[4426] = Fluid2D([2127,2136,2103],1); -ELEMENTS[4427] = Fluid2D([2103,2136,2116],1); -ELEMENTS[4428] = Fluid2D([2148,2180,2159],1); -ELEMENTS[4429] = Fluid2D([2159,2180,2191],1); -ELEMENTS[4430] = Fluid2D([2253,2245,2276],1); -ELEMENTS[4431] = Fluid2D([2276,2245,2266],1); -ELEMENTS[4432] = Fluid2D([2266,2245,2235],1); -ELEMENTS[4433] = Fluid2D([2235,2245,2213],1); -ELEMENTS[4434] = Fluid2D([2276,2266,2297],1); -ELEMENTS[4435] = Fluid2D([2276,2297,2307],1); -ELEMENTS[4436] = Fluid2D([2297,2266,2288],1); -ELEMENTS[4437] = Fluid2D([2288,2266,2257],1); -ELEMENTS[4438] = Fluid2D([2257,2266,2235],1); -ELEMENTS[4439] = Fluid2D([2307,2297,2327],1); -ELEMENTS[4440] = Fluid2D([2327,2297,2320],1); -ELEMENTS[4441] = Fluid2D([2320,2297,2288],1); -ELEMENTS[4442] = Fluid2D([2327,2320,2350],1); -ELEMENTS[4443] = Fluid2D([2350,2320,2341],1); -ELEMENTS[4444] = Fluid2D([2341,2320,2311],1); -ELEMENTS[4445] = Fluid2D([2311,2320,2288],1); -ELEMENTS[4446] = Fluid2D([2311,2288,2277],1); -ELEMENTS[4447] = Fluid2D([2311,2277,2299],1); -ELEMENTS[4448] = Fluid2D([2299,2277,2268],1); -ELEMENTS[4449] = Fluid2D([2268,2277,2247],1); -ELEMENTS[4450] = Fluid2D([2247,2277,2257],1); -ELEMENTS[4451] = Fluid2D([2277,2288,2257],1); -ELEMENTS[4452] = Fluid2D([2235,2213,2204],1); -ELEMENTS[4453] = Fluid2D([2204,2213,2181],1); -ELEMENTS[4454] = Fluid2D([2204,2181,2171],1); -ELEMENTS[4455] = Fluid2D([2181,2213,2190],1); -ELEMENTS[4456] = Fluid2D([2171,2181,2149],1); -ELEMENTS[4457] = Fluid2D([2149,2181,2158],1); -ELEMENTS[4458] = Fluid2D([2235,2204,2225],1); -ELEMENTS[4459] = Fluid2D([2225,2204,2194],1); -ELEMENTS[4460] = Fluid2D([2194,2204,2171],1); -ELEMENTS[4461] = Fluid2D([2181,2190,2158],1); -ELEMENTS[4462] = Fluid2D([2158,2190,2169],1); -ELEMENTS[4463] = Fluid2D([2257,2235,2225],1); -ELEMENTS[4464] = Fluid2D([2257,2225,2247],1); -ELEMENTS[4465] = Fluid2D([2247,2225,2216],1); -ELEMENTS[4466] = Fluid2D([2247,2216,2237],1); -ELEMENTS[4467] = Fluid2D([2237,2216,2206],1); -ELEMENTS[4468] = Fluid2D([2237,2206,2229],1); -ELEMENTS[4469] = Fluid2D([2229,2206,2197],1); -ELEMENTS[4470] = Fluid2D([2197,2206,2174],1); -ELEMENTS[4471] = Fluid2D([2174,2206,2184],1); -ELEMENTS[4472] = Fluid2D([2184,2206,2216],1); -ELEMENTS[4473] = Fluid2D([2184,2216,2194],1); -ELEMENTS[4474] = Fluid2D([2229,2197,2219],1); -ELEMENTS[4475] = Fluid2D([2219,2197,2188],1); -ELEMENTS[4476] = Fluid2D([2188,2197,2164],1); -ELEMENTS[4477] = Fluid2D([2164,2197,2174],1); -ELEMENTS[4478] = Fluid2D([2164,2174,2142],1); -ELEMENTS[4479] = Fluid2D([2142,2174,2152],1); -ELEMENTS[4480] = Fluid2D([2152,2174,2184],1); -ELEMENTS[4481] = Fluid2D([2152,2184,2160],1); -ELEMENTS[4482] = Fluid2D([2160,2184,2194],1); -ELEMENTS[4483] = Fluid2D([2160,2194,2171],1); -ELEMENTS[4484] = Fluid2D([2160,2171,2139],1); -ELEMENTS[4485] = Fluid2D([2139,2171,2149],1); -ELEMENTS[4486] = Fluid2D([2139,2149,2117],1); -ELEMENTS[4487] = Fluid2D([2117,2149,2127],1); -ELEMENTS[4488] = Fluid2D([2194,2216,2225],1); -ELEMENTS[4489] = Fluid2D([2127,2149,2158],1); -ELEMENTS[4490] = Fluid2D([2117,2127,2094],1); -ELEMENTS[4491] = Fluid2D([2117,2094,2084],1); -ELEMENTS[4492] = Fluid2D([2084,2094,2061],1); -ELEMENTS[4493] = Fluid2D([2061,2094,2070],1); -ELEMENTS[4494] = Fluid2D([2070,2094,2103],1); -ELEMENTS[4495] = Fluid2D([2117,2084,2108],1); -ELEMENTS[4496] = Fluid2D([2108,2084,2074],1); -ELEMENTS[4497] = Fluid2D([2074,2084,2052],1); -ELEMENTS[4498] = Fluid2D([2052,2084,2061],1); -ELEMENTS[4499] = Fluid2D([2094,2127,2103],1); -ELEMENTS[4500] = Fluid2D([2152,2160,2129],1); -ELEMENTS[4501] = Fluid2D([2152,2129,2119],1); -ELEMENTS[4502] = Fluid2D([2129,2160,2139],1); -ELEMENTS[4503] = Fluid2D([2129,2139,2108],1); -ELEMENTS[4504] = Fluid2D([2119,2129,2096],1); -ELEMENTS[4505] = Fluid2D([2096,2129,2108],1); -ELEMENTS[4506] = Fluid2D([2096,2108,2074],1); -ELEMENTS[4507] = Fluid2D([2096,2074,2063],1); -ELEMENTS[4508] = Fluid2D([2063,2074,2040],1); -ELEMENTS[4509] = Fluid2D([2040,2074,2052],1); -ELEMENTS[4510] = Fluid2D([2152,2119,2142],1); -ELEMENTS[4511] = Fluid2D([2142,2119,2111],1); -ELEMENTS[4512] = Fluid2D([2111,2119,2087],1); -ELEMENTS[4513] = Fluid2D([2087,2119,2096],1); -ELEMENTS[4514] = Fluid2D([2087,2096,2063],1); -ELEMENTS[4515] = Fluid2D([2108,2139,2117],1); -ELEMENTS[4516] = Fluid2D([2040,2052,2019],1); -ELEMENTS[4517] = Fluid2D([2019,2052,2029],1); -ELEMENTS[4518] = Fluid2D([2019,2029,1995],1); -ELEMENTS[4519] = Fluid2D([1995,2029,2004],1); -ELEMENTS[4520] = Fluid2D([2004,2029,2038],1); -ELEMENTS[4521] = Fluid2D([2038,2029,2061],1); -ELEMENTS[4522] = Fluid2D([2029,2052,2061],1); -ELEMENTS[4523] = Fluid2D([2040,2019,2009],1); -ELEMENTS[4524] = Fluid2D([2040,2009,2032],1); -ELEMENTS[4525] = Fluid2D([2032,2009,1998],1); -ELEMENTS[4526] = Fluid2D([1998,2009,1977],1); -ELEMENTS[4527] = Fluid2D([1977,2009,1987],1); -ELEMENTS[4528] = Fluid2D([1987,2009,2019],1); -ELEMENTS[4529] = Fluid2D([1987,2019,1995],1); -ELEMENTS[4530] = Fluid2D([1987,1995,1963],1); -ELEMENTS[4531] = Fluid2D([1963,1995,1974],1); -ELEMENTS[4532] = Fluid2D([1963,1974,1937],1); -ELEMENTS[4533] = Fluid2D([1974,1995,2004],1); -ELEMENTS[4534] = Fluid2D([1974,2004,1984],1); -ELEMENTS[4535] = Fluid2D([1984,2004,2016],1); -ELEMENTS[4536] = Fluid2D([2016,2004,2038],1); -ELEMENTS[4537] = Fluid2D([1937,1974,1951],1); -ELEMENTS[4538] = Fluid2D([1951,1974,1984],1); -ELEMENTS[4539] = Fluid2D([1937,1951,1919],1); -ELEMENTS[4540] = Fluid2D([1937,1919,1895],1); -ELEMENTS[4541] = Fluid2D([1919,1951,1928],1); -ELEMENTS[4542] = Fluid2D([1928,1951,1962],1); -ELEMENTS[4543] = Fluid2D([1919,1928,1889],1); -ELEMENTS[4544] = Fluid2D([1889,1928,1903],1); -ELEMENTS[4545] = Fluid2D([1903,1928,1942],1); -ELEMENTS[4546] = Fluid2D([1962,1951,1984],1); -ELEMENTS[4547] = Fluid2D([1942,1928,1962],1); -ELEMENTS[4548] = Fluid2D([1942,1962,1973],1); -ELEMENTS[4549] = Fluid2D([1973,1962,1994],1); -ELEMENTS[4550] = Fluid2D([1973,1994,2005],1); -ELEMENTS[4551] = Fluid2D([1994,1962,1984],1); -ELEMENTS[4552] = Fluid2D([2005,1994,2027],1); -ELEMENTS[4553] = Fluid2D([2005,2027,2039],1); -ELEMENTS[4554] = Fluid2D([2027,1994,2016],1); -ELEMENTS[4555] = Fluid2D([2039,2027,2060],1); -ELEMENTS[4556] = Fluid2D([2060,2027,2049],1); -ELEMENTS[4557] = Fluid2D([2049,2027,2016],1); -ELEMENTS[4558] = Fluid2D([2049,2016,2038],1); -ELEMENTS[4559] = Fluid2D([2032,1998,2022],1); -ELEMENTS[4560] = Fluid2D([2022,1998,1991],1); -ELEMENTS[4561] = Fluid2D([2032,2022,2055],1); -ELEMENTS[4562] = Fluid2D([1991,1998,1966],1); -ELEMENTS[4563] = Fluid2D([1966,1998,1977],1); -ELEMENTS[4564] = Fluid2D([1966,1977,1945],1); -ELEMENTS[4565] = Fluid2D([2055,2022,2044],1); -ELEMENTS[4566] = Fluid2D([2044,2022,2013],1); -ELEMENTS[4567] = Fluid2D([1945,1977,1954],1); -ELEMENTS[4568] = Fluid2D([1954,1977,1987],1); -ELEMENTS[4569] = Fluid2D([1954,1987,1963],1); -ELEMENTS[4570] = Fluid2D([1954,1963,1925],1); -ELEMENTS[4571] = Fluid2D([1925,1963,1937],1); -ELEMENTS[4572] = Fluid2D([1925,1937,1895],1); -ELEMENTS[4573] = Fluid2D([2013,2022,1991],1); -ELEMENTS[4574] = Fluid2D([2013,1991,1983],1); -ELEMENTS[4575] = Fluid2D([1983,1991,1959],1); -ELEMENTS[4576] = Fluid2D([1983,1959,1949],1); -ELEMENTS[4577] = Fluid2D([1959,1991,1966],1); -ELEMENTS[4578] = Fluid2D([1959,1966,1934],1); -ELEMENTS[4579] = Fluid2D([1934,1966,1945],1); -ELEMENTS[4580] = Fluid2D([1934,1945,1905],1); -ELEMENTS[4581] = Fluid2D([1905,1945,1915],1); -ELEMENTS[4582] = Fluid2D([1915,1945,1954],1); -ELEMENTS[4583] = Fluid2D([1905,1915,1875],1); -ELEMENTS[4584] = Fluid2D([1905,1875,1862],1); -ELEMENTS[4585] = Fluid2D([1875,1915,1886],1); -ELEMENTS[4586] = Fluid2D([1862,1875,1831],1); -ELEMENTS[4587] = Fluid2D([2016,1994,1984],1); -ELEMENTS[4588] = Fluid2D([2061,2070,2038],1); -ELEMENTS[4589] = Fluid2D([2038,2070,2049],1); -ELEMENTS[4590] = Fluid2D([2049,2070,2083],1); -ELEMENTS[4591] = Fluid2D([2049,2083,2060],1); -ELEMENTS[4592] = Fluid2D([2060,2083,2093],1); -ELEMENTS[4593] = Fluid2D([2060,2093,2071],1); -ELEMENTS[4594] = Fluid2D([2071,2093,2104],1); -ELEMENTS[4595] = Fluid2D([2104,2093,2126],1); -ELEMENTS[4596] = Fluid2D([2093,2083,2116],1); -ELEMENTS[4597] = Fluid2D([2083,2070,2103],1); -ELEMENTS[4598] = Fluid2D([2083,2103,2116],1); -ELEMENTS[4599] = Fluid2D([2126,2093,2116],1); -ELEMENTS[4600] = Fluid2D([2071,2104,2085],1); -ELEMENTS[4601] = Fluid2D([2085,2104,2118],1); -ELEMENTS[4602] = Fluid2D([2071,2085,2051],1); -ELEMENTS[4603] = Fluid2D([2051,2085,2062],1); -ELEMENTS[4604] = Fluid2D([2062,2085,2095],1); -ELEMENTS[4605] = Fluid2D([2118,2104,2138],1); -ELEMENTS[4606] = Fluid2D([2095,2085,2118],1); -ELEMENTS[4607] = Fluid2D([2095,2118,2128],1); -ELEMENTS[4608] = Fluid2D([2128,2118,2150],1); -ELEMENTS[4609] = Fluid2D([2095,2128,2109],1); -ELEMENTS[4610] = Fluid2D([2109,2128,2141],1); -ELEMENTS[4611] = Fluid2D([2141,2128,2162],1); -ELEMENTS[4612] = Fluid2D([2138,2104,2126],1); -ELEMENTS[4613] = Fluid2D([2138,2126,2159],1); -ELEMENTS[4614] = Fluid2D([2150,2118,2138],1); -ELEMENTS[4615] = Fluid2D([2162,2128,2150],1); -ELEMENTS[4616] = Fluid2D([2162,2150,2183],1); -ELEMENTS[4617] = Fluid2D([2162,2183,2195],1); -ELEMENTS[4618] = Fluid2D([2162,2195,2173],1); -ELEMENTS[4619] = Fluid2D([2195,2183,2215],1); -ELEMENTS[4620] = Fluid2D([2071,2051,2039],1); -ELEMENTS[4621] = Fluid2D([2071,2039,2060],1); -ELEMENTS[4622] = Fluid2D([2039,2051,2017],1); -ELEMENTS[4623] = Fluid2D([2017,2051,2030],1); -ELEMENTS[4624] = Fluid2D([2039,2017,2005],1); -ELEMENTS[4625] = Fluid2D([2005,2017,1986],1); -ELEMENTS[4626] = Fluid2D([1986,2017,1997],1); -ELEMENTS[4627] = Fluid2D([1986,1997,1964],1); -ELEMENTS[4628] = Fluid2D([2030,2051,2062],1); -ELEMENTS[4629] = Fluid2D([1997,2017,2030],1); -ELEMENTS[4630] = Fluid2D([1997,2030,2011],1); -ELEMENTS[4631] = Fluid2D([2011,2030,2042],1); -ELEMENTS[4632] = Fluid2D([2042,2030,2062],1); -ELEMENTS[4633] = Fluid2D([2011,2042,2021],1); -ELEMENTS[4634] = Fluid2D([2021,2042,2054],1); -ELEMENTS[4635] = Fluid2D([2054,2042,2075],1); -ELEMENTS[4636] = Fluid2D([2075,2042,2062],1); -ELEMENTS[4637] = Fluid2D([2011,2021,1989],1); -ELEMENTS[4638] = Fluid2D([2011,1989,1976],1); -ELEMENTS[4639] = Fluid2D([1989,2021,2000],1); -ELEMENTS[4640] = Fluid2D([2000,2021,2034],1); -ELEMENTS[4641] = Fluid2D([2034,2021,2054],1); -ELEMENTS[4642] = Fluid2D([1976,1989,1956],1); -ELEMENTS[4643] = Fluid2D([1976,1956,1944],1); -ELEMENTS[4644] = Fluid2D([1956,1989,1967],1); -ELEMENTS[4645] = Fluid2D([1967,1989,2000],1); -ELEMENTS[4646] = Fluid2D([1967,2000,1979],1); -ELEMENTS[4647] = Fluid2D([1979,2000,2015],1); -ELEMENTS[4648] = Fluid2D([2015,2000,2034],1); -ELEMENTS[4649] = Fluid2D([1944,1956,1922],1); -ELEMENTS[4650] = Fluid2D([1944,1922,1910],1); -ELEMENTS[4651] = Fluid2D([1922,1956,1935],1); -ELEMENTS[4652] = Fluid2D([1935,1956,1967],1); -ELEMENTS[4653] = Fluid2D([1910,1922,1888],1); -ELEMENTS[4654] = Fluid2D([1910,1888,1881],1); -ELEMENTS[4655] = Fluid2D([1888,1922,1901],1); -ELEMENTS[4656] = Fluid2D([1901,1922,1935],1); -ELEMENTS[4657] = Fluid2D([1881,1888,1855],1); -ELEMENTS[4658] = Fluid2D([1881,1855,1852],1); -ELEMENTS[4659] = Fluid2D([1855,1888,1869],1); -ELEMENTS[4660] = Fluid2D([1869,1888,1901],1); -ELEMENTS[4661] = Fluid2D([1869,1901,1880],1); -ELEMENTS[4662] = Fluid2D([1880,1901,1912],1); -ELEMENTS[4663] = Fluid2D([1855,1869,1832],1); -ELEMENTS[4664] = Fluid2D([1832,1869,1847],1); -ELEMENTS[4665] = Fluid2D([1847,1869,1880],1); -ELEMENTS[4666] = Fluid2D([1847,1880,1859],1); -ELEMENTS[4667] = Fluid2D([1859,1880,1891],1); -ELEMENTS[4668] = Fluid2D([1912,1901,1935],1); -ELEMENTS[4669] = Fluid2D([1891,1880,1912],1); -ELEMENTS[4670] = Fluid2D([1891,1912,1926],1); -ELEMENTS[4671] = Fluid2D([1926,1912,1947],1); -ELEMENTS[4672] = Fluid2D([1926,1947,1960],1); -ELEMENTS[4673] = Fluid2D([1947,1912,1935],1); -ELEMENTS[4674] = Fluid2D([1960,1947,1979],1); -ELEMENTS[4675] = Fluid2D([1979,1947,1967],1); -ELEMENTS[4676] = Fluid2D([1960,1979,1992],1); -ELEMENTS[4677] = Fluid2D([1967,1947,1935],1); -ELEMENTS[4678] = Fluid2D([1992,1979,2015],1); -ELEMENTS[4679] = Fluid2D([1992,2015,2023],1); -ELEMENTS[4680] = Fluid2D([1992,2023,2002],1); -ELEMENTS[4681] = Fluid2D([2002,2023,2037],1); -ELEMENTS[4682] = Fluid2D([2023,2015,2046],1); -ELEMENTS[4683] = Fluid2D([2046,2015,2034],1); -ELEMENTS[4684] = Fluid2D([2046,2034,2067],1); -ELEMENTS[4685] = Fluid2D([2067,2034,2054],1); -ELEMENTS[4686] = Fluid2D([2067,2054,2088],1); -ELEMENTS[4687] = Fluid2D([2088,2054,2075],1); -ELEMENTS[4688] = Fluid2D([2088,2075,2109],1); -ELEMENTS[4689] = Fluid2D([2109,2075,2095],1); -ELEMENTS[4690] = Fluid2D([2095,2075,2062],1); -ELEMENTS[4691] = Fluid2D([1964,1997,1976],1); -ELEMENTS[4692] = Fluid2D([1964,1976,1944],1); -ELEMENTS[4693] = Fluid2D([1976,1997,2011],1); -ELEMENTS[4694] = Fluid2D([1964,1944,1929],1); -ELEMENTS[4695] = Fluid2D([1964,1929,1953],1); -ELEMENTS[4696] = Fluid2D([1953,1929,1920],1); -ELEMENTS[4697] = Fluid2D([1920,1929,1896],1); -ELEMENTS[4698] = Fluid2D([1896,1929,1910],1); -ELEMENTS[4699] = Fluid2D([1929,1944,1910],1); -ELEMENTS[4700] = Fluid2D([2037,2023,2058],1); -ELEMENTS[4701] = Fluid2D([2058,2023,2046],1); -ELEMENTS[4702] = Fluid2D([2058,2046,2079],1); -ELEMENTS[4703] = Fluid2D([2079,2046,2067],1); -ELEMENTS[4704] = Fluid2D([2079,2067,2099],1); -ELEMENTS[4705] = Fluid2D([2099,2067,2088],1); -ELEMENTS[4706] = Fluid2D([2099,2088,2120],1); -ELEMENTS[4707] = Fluid2D([2120,2088,2109],1); -ELEMENTS[4708] = Fluid2D([2120,2109,2141],1); -ELEMENTS[4709] = Fluid2D([1964,1953,1986],1); -ELEMENTS[4710] = Fluid2D([1986,1953,1973],1); -ELEMENTS[4711] = Fluid2D([1986,1973,2005],1); -ELEMENTS[4712] = Fluid2D([1973,1953,1942],1); -ELEMENTS[4713] = Fluid2D([1942,1953,1920],1); -ELEMENTS[4714] = Fluid2D([1942,1920,1903],1); -ELEMENTS[4715] = Fluid2D([1903,1920,1877],1); -ELEMENTS[4716] = Fluid2D([1877,1920,1896],1); -ELEMENTS[4717] = Fluid2D([1903,1877,1863],1); -ELEMENTS[4718] = Fluid2D([1877,1896,1852],1); -ELEMENTS[4719] = Fluid2D([2142,2111,2134],1); -ELEMENTS[4720] = Fluid2D([2134,2111,2101],1); -ELEMENTS[4721] = Fluid2D([2142,2134,2164],1); -ELEMENTS[4722] = Fluid2D([2101,2111,2078],1); -ELEMENTS[4723] = Fluid2D([2078,2111,2087],1); -ELEMENTS[4724] = Fluid2D([2078,2087,2055],1); -ELEMENTS[4725] = Fluid2D([2078,2055,2044],1); -ELEMENTS[4726] = Fluid2D([2078,2044,2068],1); -ELEMENTS[4727] = Fluid2D([2055,2087,2063],1); -ELEMENTS[4728] = Fluid2D([2068,2044,2035],1); -ELEMENTS[4729] = Fluid2D([2035,2044,2013],1); -ELEMENTS[4730] = Fluid2D([2164,2134,2156],1); -ELEMENTS[4731] = Fluid2D([2156,2134,2123],1); -ELEMENTS[4732] = Fluid2D([2123,2134,2101],1); -ELEMENTS[4733] = Fluid2D([2123,2101,2091],1); -ELEMENTS[4734] = Fluid2D([2091,2101,2068],1); -ELEMENTS[4735] = Fluid2D([2068,2101,2078],1); -ELEMENTS[4736] = Fluid2D([2123,2091,2114],1); -ELEMENTS[4737] = Fluid2D([2114,2091,2082],1); -ELEMENTS[4738] = Fluid2D([2082,2091,2059],1); -ELEMENTS[4739] = Fluid2D([2059,2091,2068],1); -ELEMENTS[4740] = Fluid2D([2114,2082,2107],1); -ELEMENTS[4741] = Fluid2D([2107,2082,2072],1); -ELEMENTS[4742] = Fluid2D([2107,2072,2097],1); -ELEMENTS[4743] = Fluid2D([2097,2072,2065],1); -ELEMENTS[4744] = Fluid2D([2065,2072,2036],1); -ELEMENTS[4745] = Fluid2D([2036,2072,2048],1); -ELEMENTS[4746] = Fluid2D([2048,2072,2082],1); -ELEMENTS[4747] = Fluid2D([2059,2068,2035],1); -ELEMENTS[4748] = Fluid2D([2059,2035,2026],1); -ELEMENTS[4749] = Fluid2D([2059,2026,2048],1); -ELEMENTS[4750] = Fluid2D([2048,2026,2006],1); -ELEMENTS[4751] = Fluid2D([2026,2035,2007],1); -ELEMENTS[4752] = Fluid2D([2006,2026,1982],1); -ELEMENTS[4753] = Fluid2D([2007,2035,2013],1); -ELEMENTS[4754] = Fluid2D([2007,2013,1983],1); -ELEMENTS[4755] = Fluid2D([2007,1983,1982],1); -ELEMENTS[4756] = Fluid2D([2055,2063,2032],1); -ELEMENTS[4757] = Fluid2D([2032,2063,2040],1); -ELEMENTS[4758] = Fluid2D([2048,2082,2059],1); -ELEMENTS[4759] = Fluid2D([2036,2048,2006],1); -ELEMENTS[4760] = Fluid2D([2036,2006,1996],1); -ELEMENTS[4761] = Fluid2D([2123,2114,2146],1); -ELEMENTS[4762] = Fluid2D([2123,2146,2156],1); -ELEMENTS[4763] = Fluid2D([2146,2114,2137],1); -ELEMENTS[4764] = Fluid2D([2137,2114,2107],1); -ELEMENTS[4765] = Fluid2D([2137,2107,2130],1); -ELEMENTS[4766] = Fluid2D([2137,2130,2161],1); -ELEMENTS[4767] = Fluid2D([2130,2107,2097],1); -ELEMENTS[4768] = Fluid2D([2161,2130,2154],1); -ELEMENTS[4769] = Fluid2D([2161,2154,2185],1); -ELEMENTS[4770] = Fluid2D([2154,2130,2121],1); -ELEMENTS[4771] = Fluid2D([2121,2130,2097],1); -ELEMENTS[4772] = Fluid2D([2121,2097,2089],1); -ELEMENTS[4773] = Fluid2D([2089,2097,2065],1); -ELEMENTS[4774] = Fluid2D([2089,2065,2057],1); -ELEMENTS[4775] = Fluid2D([2121,2089,2113],1); -ELEMENTS[4776] = Fluid2D([2113,2089,2081],1); -ELEMENTS[4777] = Fluid2D([2081,2089,2057],1); -ELEMENTS[4778] = Fluid2D([2081,2057,2047],1); -ELEMENTS[4779] = Fluid2D([2047,2057,2020],1); -ELEMENTS[4780] = Fluid2D([2020,2057,2028],1); -ELEMENTS[4781] = Fluid2D([2028,2057,2065],1); -ELEMENTS[4782] = Fluid2D([2081,2047,2073],1); -ELEMENTS[4783] = Fluid2D([2073,2047,2041],1); -ELEMENTS[4784] = Fluid2D([2081,2073,2105],1); -ELEMENTS[4785] = Fluid2D([2041,2047,2012],1); -ELEMENTS[4786] = Fluid2D([2105,2073,2098],1); -ELEMENTS[4787] = Fluid2D([2098,2073,2066],1); -ELEMENTS[4788] = Fluid2D([2012,2047,2020],1); -ELEMENTS[4789] = Fluid2D([2066,2073,2041],1); -ELEMENTS[4790] = Fluid2D([2066,2041,2024],1); -ELEMENTS[4791] = Fluid2D([2024,2041,2001],1); -ELEMENTS[4792] = Fluid2D([2024,2001,1981],1); -ELEMENTS[4793] = Fluid2D([2001,2041,2012],1); -ELEMENTS[4794] = Fluid2D([2001,2012,1971],1); -ELEMENTS[4795] = Fluid2D([1971,2012,1980],1); -ELEMENTS[4796] = Fluid2D([2156,2146,2178],1); -ELEMENTS[4797] = Fluid2D([2156,2178,2188],1); -ELEMENTS[4798] = Fluid2D([2178,2146,2168],1); -ELEMENTS[4799] = Fluid2D([2168,2146,2137],1); -ELEMENTS[4800] = Fluid2D([2156,2188,2164],1); -ELEMENTS[4801] = Fluid2D([2188,2178,2211],1); -ELEMENTS[4802] = Fluid2D([2188,2211,2219],1); -ELEMENTS[4803] = Fluid2D([2211,2178,2200],1); -ELEMENTS[4804] = Fluid2D([2200,2178,2168],1); -ELEMENTS[4805] = Fluid2D([2219,2211,2242],1); -ELEMENTS[4806] = Fluid2D([2219,2242,2250],1); -ELEMENTS[4807] = Fluid2D([2242,2211,2232],1); -ELEMENTS[4808] = Fluid2D([2232,2211,2200],1); -ELEMENTS[4809] = Fluid2D([2242,2232,2263],1); -ELEMENTS[4810] = Fluid2D([2250,2242,2273],1); -ELEMENTS[4811] = Fluid2D([2273,2242,2263],1); -ELEMENTS[4812] = Fluid2D([2273,2263,2295],1); -ELEMENTS[4813] = Fluid2D([2273,2295,2302],1); -ELEMENTS[4814] = Fluid2D([2273,2302,2281],1); -ELEMENTS[4815] = Fluid2D([2263,2232,2254],1); -ELEMENTS[4816] = Fluid2D([2254,2232,2224],1); -ELEMENTS[4817] = Fluid2D([2224,2232,2200],1); -ELEMENTS[4818] = Fluid2D([2224,2200,2193],1); -ELEMENTS[4819] = Fluid2D([2193,2200,2168],1); -ELEMENTS[4820] = Fluid2D([2193,2168,2161],1); -ELEMENTS[4821] = Fluid2D([2161,2168,2137],1); -ELEMENTS[4822] = Fluid2D([2273,2281,2250],1); -ELEMENTS[4823] = Fluid2D([2250,2281,2260],1); -ELEMENTS[4824] = Fluid2D([2260,2281,2291],1); -ELEMENTS[4825] = Fluid2D([2260,2291,2268],1); -ELEMENTS[4826] = Fluid2D([2268,2291,2299],1); -ELEMENTS[4827] = Fluid2D([2299,2291,2321],1); -ELEMENTS[4828] = Fluid2D([2299,2321,2329],1); -ELEMENTS[4829] = Fluid2D([2299,2329,2311],1); -ELEMENTS[4830] = Fluid2D([2311,2329,2341],1); -ELEMENTS[4831] = Fluid2D([2341,2329,2361],1); -ELEMENTS[4832] = Fluid2D([2260,2268,2237],1); -ELEMENTS[4833] = Fluid2D([2260,2237,2229],1); -ELEMENTS[4834] = Fluid2D([2260,2229,2250],1); -ELEMENTS[4835] = Fluid2D([2250,2229,2219],1); -ELEMENTS[4836] = Fluid2D([2237,2268,2247],1); -ELEMENTS[4837] = Fluid2D([2028,2065,2036],1); -ELEMENTS[4838] = Fluid2D([2028,2036,1996],1); -ELEMENTS[4839] = Fluid2D([2098,2066,2090],1); -ELEMENTS[4840] = Fluid2D([2090,2066,2050],1); -ELEMENTS[4841] = Fluid2D([2098,2090,2122],1); -ELEMENTS[4842] = Fluid2D([2050,2066,2024],1); -ELEMENTS[4843] = Fluid2D([2050,2024,2003],1); -ELEMENTS[4844] = Fluid2D([2122,2090,2115],1); -ELEMENTS[4845] = Fluid2D([2122,2115,2147],1); -ELEMENTS[4846] = Fluid2D([2115,2090,2076],1); -ELEMENTS[4847] = Fluid2D([2147,2115,2140],1); -ELEMENTS[4848] = Fluid2D([2147,2140,2172],1); -ELEMENTS[4849] = Fluid2D([2140,2115,2100],1); -ELEMENTS[4850] = Fluid2D([2076,2090,2050],1); -ELEMENTS[4851] = Fluid2D([2172,2140,2165],1); -ELEMENTS[4852] = Fluid2D([2172,2165,2196],1); -ELEMENTS[4853] = Fluid2D([2165,2140,2125],1); -ELEMENTS[4854] = Fluid2D([2100,2115,2076],1); -ELEMENTS[4855] = Fluid2D([2196,2165,2189],1); -ELEMENTS[4856] = Fluid2D([2196,2189,2220],1); -ELEMENTS[4857] = Fluid2D([2189,2165,2151],1); -ELEMENTS[4858] = Fluid2D([2125,2140,2100],1); -ELEMENTS[4859] = Fluid2D([2125,2100,2080],1); -ELEMENTS[4860] = Fluid2D([2220,2189,2214],1); -ELEMENTS[4861] = Fluid2D([2220,2214,2244],1); -ELEMENTS[4862] = Fluid2D([2214,2189,2175],1); -ELEMENTS[4863] = Fluid2D([2151,2165,2125],1); -ELEMENTS[4864] = Fluid2D([2151,2125,2106],1); -ELEMENTS[4865] = Fluid2D([2175,2189,2151],1); -ELEMENTS[4866] = Fluid2D([2175,2151,2132],1); -ELEMENTS[4867] = Fluid2D([2244,2214,2238],1); -ELEMENTS[4868] = Fluid2D([2244,2238,2269],1); -ELEMENTS[4869] = Fluid2D([2238,2214,2198],1); -ELEMENTS[4870] = Fluid2D([2238,2198,2227],1); -ELEMENTS[4871] = Fluid2D([2227,2198,2182],1); -ELEMENTS[4872] = Fluid2D([2198,2214,2175],1); -ELEMENTS[4873] = Fluid2D([2198,2175,2157],1); -ELEMENTS[4874] = Fluid2D([2269,2238,2262],1); -ELEMENTS[4875] = Fluid2D([2262,2238,2227],1); -ELEMENTS[4876] = Fluid2D([2262,2227,2259],1); -ELEMENTS[4877] = Fluid2D([2259,2227,2230],1); -ELEMENTS[4878] = Fluid2D([2262,2259,2289],1); -ELEMENTS[4879] = Fluid2D([2289,2259,2283],1); -ELEMENTS[4880] = Fluid2D([2283,2259,2256],1); -ELEMENTS[4881] = Fluid2D([2098,2122,2131],1); -ELEMENTS[4882] = Fluid2D([2098,2131,2105],1); -ELEMENTS[4883] = Fluid2D([2105,2131,2135],1); -ELEMENTS[4884] = Fluid2D([2135,2131,2163],1); -ELEMENTS[4885] = Fluid2D([2135,2163,2167],1); -ELEMENTS[4886] = Fluid2D([2163,2131,2155],1); -ELEMENTS[4887] = Fluid2D([2155,2131,2122],1); -ELEMENTS[4888] = Fluid2D([2167,2163,2192],1); -ELEMENTS[4889] = Fluid2D([2167,2192,2199],1); -ELEMENTS[4890] = Fluid2D([2192,2163,2187],1); -ELEMENTS[4891] = Fluid2D([2187,2163,2155],1); -ELEMENTS[4892] = Fluid2D([2187,2155,2179],1); -ELEMENTS[4893] = Fluid2D([2179,2155,2147],1); -ELEMENTS[4894] = Fluid2D([2147,2155,2122],1); -ELEMENTS[4895] = Fluid2D([2199,2192,2223],1); -ELEMENTS[4896] = Fluid2D([2223,2192,2218],1); -ELEMENTS[4897] = Fluid2D([2218,2192,2187],1); -ELEMENTS[4898] = Fluid2D([2218,2187,2210],1); -ELEMENTS[4899] = Fluid2D([2210,2187,2179],1); -ELEMENTS[4900] = Fluid2D([2210,2179,2202],1); -ELEMENTS[4901] = Fluid2D([2202,2179,2172],1); -ELEMENTS[4902] = Fluid2D([2172,2179,2147],1); -ELEMENTS[4903] = Fluid2D([2202,2172,2196],1); -ELEMENTS[4904] = Fluid2D([2202,2196,2228],1); -ELEMENTS[4905] = Fluid2D([2228,2196,2220],1); -ELEMENTS[4906] = Fluid2D([2228,2220,2251],1); -ELEMENTS[4907] = Fluid2D([2251,2220,2244],1); -ELEMENTS[4908] = Fluid2D([2105,2135,2113],1); -ELEMENTS[4909] = Fluid2D([2113,2135,2145],1); -ELEMENTS[4910] = Fluid2D([2145,2135,2167],1); -ELEMENTS[4911] = Fluid2D([2145,2167,2177],1); -ELEMENTS[4912] = Fluid2D([2177,2167,2199],1); -ELEMENTS[4913] = Fluid2D([2105,2113,2081],1); -ELEMENTS[4914] = Fluid2D([2177,2199,2209],1); -ELEMENTS[4915] = Fluid2D([2177,2209,2185],1); -ELEMENTS[4916] = Fluid2D([2177,2185,2154],1); -ELEMENTS[4917] = Fluid2D([2177,2154,2145],1); -ELEMENTS[4918] = Fluid2D([2145,2154,2121],1); -ELEMENTS[4919] = Fluid2D([2145,2121,2113],1); -ELEMENTS[4920] = Fluid2D([2012,2020,1980],1); -ELEMENTS[4921] = Fluid2D([2308,2296,2326],1); -ELEMENTS[4922] = Fluid2D([2161,2185,2193],1); -ELEMENTS[4923] = Fluid2D([2026,2007,1982],1); -ELEMENTS[4924] = Fluid2D([2002,2037,2018],1); -ELEMENTS[4925] = Fluid2D([2002,2018,1985],1); -ELEMENTS[4926] = Fluid2D([1985,2018,1999],1); -ELEMENTS[4927] = Fluid2D([1999,2018,2033],1); -ELEMENTS[4928] = Fluid2D([1999,2033,2014],1); -ELEMENTS[4929] = Fluid2D([2014,2033,2045],1); -ELEMENTS[4930] = Fluid2D([1985,1999,1965],1); -ELEMENTS[4931] = Fluid2D([1965,1999,1978],1); -ELEMENTS[4932] = Fluid2D([1985,1965,1952],1); -ELEMENTS[4933] = Fluid2D([1952,1965,1933],1); -ELEMENTS[4934] = Fluid2D([1933,1965,1946],1); -ELEMENTS[4935] = Fluid2D([1946,1965,1978],1); -ELEMENTS[4936] = Fluid2D([1946,1978,1961],1); -ELEMENTS[4937] = Fluid2D([1961,1978,1993],1); -ELEMENTS[4938] = Fluid2D([1961,1993,1972],1); -ELEMENTS[4939] = Fluid2D([1972,1993,2008],1); -ELEMENTS[4940] = Fluid2D([1978,1999,2014],1); -ELEMENTS[4941] = Fluid2D([2008,1993,2025],1); -ELEMENTS[4942] = Fluid2D([2018,2037,2053],1); -ELEMENTS[4943] = Fluid2D([2025,1993,2014],1); -ELEMENTS[4944] = Fluid2D([2014,1993,1978],1); -ELEMENTS[4945] = Fluid2D([2025,2014,2045],1); -ELEMENTS[4946] = Fluid2D([2018,2053,2033],1); -ELEMENTS[4947] = Fluid2D([2033,2053,2064],1); -ELEMENTS[4948] = Fluid2D([2064,2053,2086],1); -ELEMENTS[4949] = Fluid2D([2033,2064,2045],1); -ELEMENTS[4950] = Fluid2D([1985,1952,1970],1); -ELEMENTS[4951] = Fluid2D([1970,1952,1938],1); -ELEMENTS[4952] = Fluid2D([1938,1952,1918],1); -ELEMENTS[4953] = Fluid2D([1938,1918,1904],1); -ELEMENTS[4954] = Fluid2D([1918,1952,1933],1); -ELEMENTS[4955] = Fluid2D([1918,1933,1898],1); -ELEMENTS[4956] = Fluid2D([1898,1933,1911],1); -ELEMENTS[4957] = Fluid2D([1918,1898,1885],1); -ELEMENTS[4958] = Fluid2D([1911,1933,1946],1); -ELEMENTS[4959] = Fluid2D([1911,1946,1927],1); -ELEMENTS[4960] = Fluid2D([1911,1927,1892],1); -ELEMENTS[4961] = Fluid2D([1892,1927,1906],1); -ELEMENTS[4962] = Fluid2D([1906,1927,1941],1); -ELEMENTS[4963] = Fluid2D([1985,1970,2002],1); -ELEMENTS[4964] = Fluid2D([2002,1970,1992],1); -ELEMENTS[4965] = Fluid2D([1941,1927,1961],1); -ELEMENTS[4966] = Fluid2D([1941,1961,1972],1); -ELEMENTS[4967] = Fluid2D([1941,1972,1955],1); -ELEMENTS[4968] = Fluid2D([1961,1927,1946],1); -ELEMENTS[4969] = Fluid2D([1955,1972,1988],1); -ELEMENTS[4970] = Fluid2D([1988,1972,2008],1); -ELEMENTS[4971] = Fluid2D([1885,1898,1866],1); -ELEMENTS[4972] = Fluid2D([1866,1898,1878],1); -ELEMENTS[4973] = Fluid2D([1878,1898,1911],1); -ELEMENTS[4974] = Fluid2D([1866,1878,1845],1); -ELEMENTS[4975] = Fluid2D([1866,1845,1830],1); -ELEMENTS[4976] = Fluid2D([1845,1878,1858],1); -ELEMENTS[4977] = Fluid2D([1858,1878,1892],1); -ELEMENTS[4978] = Fluid2D([1892,1878,1911],1); -ELEMENTS[4979] = Fluid2D([1830,1845,1811],1); -ELEMENTS[4980] = Fluid2D([1830,1811,1794],1); -ELEMENTS[4981] = Fluid2D([1811,1845,1824],1); -ELEMENTS[4982] = Fluid2D([1824,1845,1858],1); -ELEMENTS[4983] = Fluid2D([1811,1824,1788],1); -ELEMENTS[4984] = Fluid2D([1811,1788,1773],1); -ELEMENTS[4985] = Fluid2D([1788,1824,1801],1); -ELEMENTS[4986] = Fluid2D([1801,1824,1838],1); -ELEMENTS[4987] = Fluid2D([1794,1811,1773],1); -ELEMENTS[4988] = Fluid2D([1794,1773,1755],1); -ELEMENTS[4989] = Fluid2D([1773,1788,1751],1); -ELEMENTS[4990] = Fluid2D([1751,1788,1764],1); -ELEMENTS[4991] = Fluid2D([1764,1788,1801],1); -ELEMENTS[4992] = Fluid2D([1755,1773,1736],1); -ELEMENTS[4993] = Fluid2D([1755,1736,1718],1); -ELEMENTS[4994] = Fluid2D([1736,1773,1751],1); -ELEMENTS[4995] = Fluid2D([1718,1736,1697],1); -ELEMENTS[4996] = Fluid2D([1697,1736,1715],1); -ELEMENTS[4997] = Fluid2D([1715,1736,1751],1); -ELEMENTS[4998] = Fluid2D([1838,1824,1858],1); -ELEMENTS[4999] = Fluid2D([1838,1858,1872],1); -ELEMENTS[5000] = Fluid2D([1838,1872,1854],1); -ELEMENTS[5001] = Fluid2D([1854,1872,1887],1); -ELEMENTS[5002] = Fluid2D([1887,1872,1906],1); -ELEMENTS[5003] = Fluid2D([1906,1872,1892],1); -ELEMENTS[5004] = Fluid2D([1892,1872,1858],1); -ELEMENTS[5005] = Fluid2D([1715,1751,1726],1); -ELEMENTS[5006] = Fluid2D([1726,1751,1764],1); -ELEMENTS[5007] = Fluid2D([1715,1726,1687],1); -ELEMENTS[5008] = Fluid2D([1715,1687,1675],1); -ELEMENTS[5009] = Fluid2D([1687,1726,1705],1); -ELEMENTS[5010] = Fluid2D([1705,1726,1742],1); -ELEMENTS[5011] = Fluid2D([1675,1687,1649],1); -ELEMENTS[5012] = Fluid2D([1649,1687,1665],1); -ELEMENTS[5013] = Fluid2D([1665,1687,1705],1); -ELEMENTS[5014] = Fluid2D([1665,1705,1683],1); -ELEMENTS[5015] = Fluid2D([1683,1705,1722],1); -ELEMENTS[5016] = Fluid2D([1742,1726,1764],1); -ELEMENTS[5017] = Fluid2D([1742,1764,1780],1); -ELEMENTS[5018] = Fluid2D([1780,1764,1801],1); -ELEMENTS[5019] = Fluid2D([1780,1801,1818],1); -ELEMENTS[5020] = Fluid2D([1818,1801,1838],1); -ELEMENTS[5021] = Fluid2D([1722,1705,1742],1); -ELEMENTS[5022] = Fluid2D([1722,1742,1761],1); -ELEMENTS[5023] = Fluid2D([1761,1742,1780],1); -ELEMENTS[5024] = Fluid2D([1761,1780,1798],1); -ELEMENTS[5025] = Fluid2D([1798,1780,1818],1); -ELEMENTS[5026] = Fluid2D([1798,1818,1834],1); -ELEMENTS[5027] = Fluid2D([1798,1834,1814],1); -ELEMENTS[5028] = Fluid2D([1814,1834,1849],1); -ELEMENTS[5029] = Fluid2D([1849,1834,1870],1); -ELEMENTS[5030] = Fluid2D([1870,1834,1854],1); -ELEMENTS[5031] = Fluid2D([1854,1834,1818],1); -ELEMENTS[5032] = Fluid2D([1854,1818,1838],1); -ELEMENTS[5033] = Fluid2D([1761,1798,1777],1); -ELEMENTS[5034] = Fluid2D([1777,1798,1814],1); -ELEMENTS[5035] = Fluid2D([1761,1777,1740],1); -ELEMENTS[5036] = Fluid2D([1761,1740,1722],1); -ELEMENTS[5037] = Fluid2D([1740,1777,1754],1); -ELEMENTS[5038] = Fluid2D([1740,1754,1717],1); -ELEMENTS[5039] = Fluid2D([1717,1754,1737],1); -ELEMENTS[5040] = Fluid2D([1737,1754,1774],1); -ELEMENTS[5041] = Fluid2D([1722,1740,1700],1); -ELEMENTS[5042] = Fluid2D([1700,1740,1717],1); -ELEMENTS[5043] = Fluid2D([1777,1814,1792],1); -ELEMENTS[5044] = Fluid2D([1792,1814,1828],1); -ELEMENTS[5045] = Fluid2D([1777,1792,1754],1); -ELEMENTS[5046] = Fluid2D([1754,1792,1774],1); -ELEMENTS[5047] = Fluid2D([1774,1792,1812],1); -ELEMENTS[5048] = Fluid2D([1828,1814,1849],1); -ELEMENTS[5049] = Fluid2D([1774,1812,1789],1); -ELEMENTS[5050] = Fluid2D([1789,1812,1827],1); -ELEMENTS[5051] = Fluid2D([1774,1789,1752],1); -ELEMENTS[5052] = Fluid2D([1752,1789,1770],1); -ELEMENTS[5053] = Fluid2D([1770,1789,1807],1); -ELEMENTS[5054] = Fluid2D([1827,1812,1846],1); -ELEMENTS[5055] = Fluid2D([1846,1812,1828],1); -ELEMENTS[5056] = Fluid2D([1828,1812,1792],1); -ELEMENTS[5057] = Fluid2D([1807,1789,1827],1); -ELEMENTS[5058] = Fluid2D([1807,1827,1844],1); -ELEMENTS[5059] = Fluid2D([1844,1827,1861],1); -ELEMENTS[5060] = Fluid2D([1844,1861,1876],1); -ELEMENTS[5061] = Fluid2D([1876,1861,1894],1); -ELEMENTS[5062] = Fluid2D([1894,1861,1879],1); -ELEMENTS[5063] = Fluid2D([1879,1861,1846],1); -ELEMENTS[5064] = Fluid2D([1879,1846,1865],1); -ELEMENTS[5065] = Fluid2D([1865,1846,1828],1); -ELEMENTS[5066] = Fluid2D([1865,1828,1849],1); -ELEMENTS[5067] = Fluid2D([1865,1849,1883],1); -ELEMENTS[5068] = Fluid2D([1883,1849,1870],1); -ELEMENTS[5069] = Fluid2D([1861,1827,1846],1); -ELEMENTS[5070] = Fluid2D([1883,1870,1902],1); -ELEMENTS[5071] = Fluid2D([1902,1870,1887],1); -ELEMENTS[5072] = Fluid2D([1887,1870,1854],1); -ELEMENTS[5073] = Fluid2D([1883,1902,1917],1); -ELEMENTS[5074] = Fluid2D([1917,1902,1936],1); -ELEMENTS[5075] = Fluid2D([1936,1902,1921],1); -ELEMENTS[5076] = Fluid2D([1921,1902,1887],1); -ELEMENTS[5077] = Fluid2D([1936,1921,1955],1); -ELEMENTS[5078] = Fluid2D([1955,1921,1941],1); -ELEMENTS[5079] = Fluid2D([1921,1887,1906],1); -ELEMENTS[5080] = Fluid2D([1941,1921,1906],1); -ELEMENTS[5081] = Fluid2D([1936,1955,1969],1); -ELEMENTS[5082] = Fluid2D([1936,1969,1950],1); -ELEMENTS[5083] = Fluid2D([1969,1955,1988],1); -ELEMENTS[5084] = Fluid2D([1770,1807,1787],1); -ELEMENTS[5085] = Fluid2D([1787,1807,1823],1); -ELEMENTS[5086] = Fluid2D([1770,1787,1750],1); -ELEMENTS[5087] = Fluid2D([1770,1750,1732],1); -ELEMENTS[5088] = Fluid2D([1750,1787,1768],1); -ELEMENTS[5089] = Fluid2D([1768,1787,1805],1); -ELEMENTS[5090] = Fluid2D([1823,1807,1844],1); -ELEMENTS[5091] = Fluid2D([1732,1750,1713],1); -ELEMENTS[5092] = Fluid2D([1732,1713,1694],1); -ELEMENTS[5093] = Fluid2D([1713,1750,1731],1); -ELEMENTS[5094] = Fluid2D([1731,1750,1768],1); -ELEMENTS[5095] = Fluid2D([1805,1787,1823],1); -ELEMENTS[5096] = Fluid2D([1805,1823,1840],1); -ELEMENTS[5097] = Fluid2D([1805,1840,1822],1); -ELEMENTS[5098] = Fluid2D([1805,1822,1786],1); -ELEMENTS[5099] = Fluid2D([1840,1823,1857],1); -ELEMENTS[5100] = Fluid2D([1857,1823,1844],1); -ELEMENTS[5101] = Fluid2D([1786,1822,1803],1); -ELEMENTS[5102] = Fluid2D([1786,1803,1766],1); -ELEMENTS[5103] = Fluid2D([1766,1803,1784],1); -ELEMENTS[5104] = Fluid2D([1694,1713,1674],1); -ELEMENTS[5105] = Fluid2D([1694,1674,1655],1); -ELEMENTS[5106] = Fluid2D([1674,1713,1692],1); -ELEMENTS[5107] = Fluid2D([1692,1713,1731],1); -ELEMENTS[5108] = Fluid2D([1655,1674,1634],1); -ELEMENTS[5109] = Fluid2D([1655,1634,1615],1); -ELEMENTS[5110] = Fluid2D([1634,1674,1653],1); -ELEMENTS[5111] = Fluid2D([1653,1674,1692],1); -ELEMENTS[5112] = Fluid2D([1653,1692,1672],1); -ELEMENTS[5113] = Fluid2D([1672,1692,1711],1); -ELEMENTS[5114] = Fluid2D([1615,1634,1594],1); -ELEMENTS[5115] = Fluid2D([1594,1634,1613],1); -ELEMENTS[5116] = Fluid2D([1613,1634,1653],1); -ELEMENTS[5117] = Fluid2D([1711,1692,1731],1); -ELEMENTS[5118] = Fluid2D([1711,1731,1748],1); -ELEMENTS[5119] = Fluid2D([1711,1748,1728],1); -ELEMENTS[5120] = Fluid2D([1728,1748,1766],1); -ELEMENTS[5121] = Fluid2D([1766,1748,1786],1); -ELEMENTS[5122] = Fluid2D([1786,1748,1768],1); -ELEMENTS[5123] = Fluid2D([1768,1748,1731],1); -ELEMENTS[5124] = Fluid2D([1766,1784,1746],1); -ELEMENTS[5125] = Fluid2D([1766,1746,1728],1); -ELEMENTS[5126] = Fluid2D([1728,1746,1709],1); -ELEMENTS[5127] = Fluid2D([1709,1746,1727],1); -ELEMENTS[5128] = Fluid2D([1709,1727,1688],1); -ELEMENTS[5129] = Fluid2D([1727,1746,1765],1); -ELEMENTS[5130] = Fluid2D([1688,1727,1710],1); -ELEMENTS[5131] = Fluid2D([1710,1727,1747],1); -ELEMENTS[5132] = Fluid2D([1747,1727,1765],1); -ELEMENTS[5133] = Fluid2D([1746,1784,1765],1); -ELEMENTS[5134] = Fluid2D([1655,1615,1637],1); -ELEMENTS[5135] = Fluid2D([1637,1615,1598],1); -ELEMENTS[5136] = Fluid2D([1655,1637,1678],1); -ELEMENTS[5137] = Fluid2D([1655,1678,1694],1); -ELEMENTS[5138] = Fluid2D([1678,1637,1659],1); -ELEMENTS[5139] = Fluid2D([1659,1637,1619],1); -ELEMENTS[5140] = Fluid2D([1694,1678,1716],1); -ELEMENTS[5141] = Fluid2D([1716,1678,1698],1); -ELEMENTS[5142] = Fluid2D([1698,1678,1659],1); -ELEMENTS[5143] = Fluid2D([1698,1659,1679],1); -ELEMENTS[5144] = Fluid2D([1679,1659,1640],1); -ELEMENTS[5145] = Fluid2D([1598,1615,1575],1); -ELEMENTS[5146] = Fluid2D([1575,1615,1594],1); -ELEMENTS[5147] = Fluid2D([1619,1637,1598],1); -ELEMENTS[5148] = Fluid2D([1619,1598,1577],1); -ELEMENTS[5149] = Fluid2D([1619,1577,1600],1); -ELEMENTS[5150] = Fluid2D([1600,1577,1559],1); -ELEMENTS[5151] = Fluid2D([1577,1598,1557],1); -ELEMENTS[5152] = Fluid2D([1557,1598,1575],1); -ELEMENTS[5153] = Fluid2D([1559,1577,1536],1); -ELEMENTS[5154] = Fluid2D([1559,1536,1518],1); -ELEMENTS[5155] = Fluid2D([1536,1577,1557],1); -ELEMENTS[5156] = Fluid2D([1518,1536,1495],1); -ELEMENTS[5157] = Fluid2D([1495,1536,1515],1); -ELEMENTS[5158] = Fluid2D([1515,1536,1557],1); -ELEMENTS[5159] = Fluid2D([1515,1557,1533],1); -ELEMENTS[5160] = Fluid2D([1533,1557,1575],1); -ELEMENTS[5161] = Fluid2D([1515,1533,1492],1); -ELEMENTS[5162] = Fluid2D([1492,1533,1511],1); -ELEMENTS[5163] = Fluid2D([1511,1533,1553],1); -ELEMENTS[5164] = Fluid2D([1553,1533,1575],1); -ELEMENTS[5165] = Fluid2D([1553,1575,1594],1); -ELEMENTS[5166] = Fluid2D([1640,1659,1619],1); -ELEMENTS[5167] = Fluid2D([1640,1619,1600],1); -ELEMENTS[5168] = Fluid2D([1553,1594,1573],1); -ELEMENTS[5169] = Fluid2D([1573,1594,1613],1); -ELEMENTS[5170] = Fluid2D([1553,1573,1531],1); -ELEMENTS[5171] = Fluid2D([1531,1573,1548],1); -ELEMENTS[5172] = Fluid2D([1548,1573,1590],1); -ELEMENTS[5173] = Fluid2D([1590,1573,1613],1); -ELEMENTS[5174] = Fluid2D([1590,1613,1631],1); -ELEMENTS[5175] = Fluid2D([1631,1613,1653],1); -ELEMENTS[5176] = Fluid2D([1631,1653,1672],1); -ELEMENTS[5177] = Fluid2D([1590,1631,1609],1); -ELEMENTS[5178] = Fluid2D([1609,1631,1650],1); -ELEMENTS[5179] = Fluid2D([1590,1609,1568],1); -ELEMENTS[5180] = Fluid2D([1590,1568,1548],1); -ELEMENTS[5181] = Fluid2D([1568,1609,1587],1); -ELEMENTS[5182] = Fluid2D([1568,1587,1546],1); -ELEMENTS[5183] = Fluid2D([1546,1587,1567],1); -ELEMENTS[5184] = Fluid2D([1567,1587,1607],1); -ELEMENTS[5185] = Fluid2D([1650,1631,1672],1); -ELEMENTS[5186] = Fluid2D([1650,1672,1689],1); -ELEMENTS[5187] = Fluid2D([1548,1568,1526],1); -ELEMENTS[5188] = Fluid2D([1526,1568,1546],1); -ELEMENTS[5189] = Fluid2D([1689,1672,1711],1); -ELEMENTS[5190] = Fluid2D([1689,1711,1728],1); -ELEMENTS[5191] = Fluid2D([1689,1728,1709],1); -ELEMENTS[5192] = Fluid2D([1689,1709,1669],1); -ELEMENTS[5193] = Fluid2D([1689,1669,1650],1); -ELEMENTS[5194] = Fluid2D([1650,1669,1628],1); -ELEMENTS[5195] = Fluid2D([1669,1709,1688],1); -ELEMENTS[5196] = Fluid2D([1669,1688,1648],1); -ELEMENTS[5197] = Fluid2D([1628,1669,1648],1); -ELEMENTS[5198] = Fluid2D([1628,1648,1607],1); -ELEMENTS[5199] = Fluid2D([1607,1648,1629],1); -ELEMENTS[5200] = Fluid2D([1629,1648,1671],1); -ELEMENTS[5201] = Fluid2D([1648,1688,1671],1); -ELEMENTS[5202] = Fluid2D([1671,1688,1710],1); -ELEMENTS[5203] = Fluid2D([1671,1710,1691],1); -ELEMENTS[5204] = Fluid2D([1671,1691,1652],1); -ELEMENTS[5205] = Fluid2D([1691,1710,1730],1); -ELEMENTS[5206] = Fluid2D([1652,1691,1673],1); -ELEMENTS[5207] = Fluid2D([1730,1710,1747],1); -ELEMENTS[5208] = Fluid2D([1673,1691,1712],1); -ELEMENTS[5209] = Fluid2D([1607,1587,1628],1); -ELEMENTS[5210] = Fluid2D([1628,1587,1609],1); -ELEMENTS[5211] = Fluid2D([1712,1691,1730],1); -ELEMENTS[5212] = Fluid2D([1698,1679,1717],1); -ELEMENTS[5213] = Fluid2D([1698,1717,1737],1); -ELEMENTS[5214] = Fluid2D([1717,1679,1700],1); -ELEMENTS[5215] = Fluid2D([1700,1679,1662],1); -ELEMENTS[5216] = Fluid2D([1662,1679,1640],1); -ELEMENTS[5217] = Fluid2D([1662,1640,1624],1); -ELEMENTS[5218] = Fluid2D([1624,1640,1600],1); -ELEMENTS[5219] = Fluid2D([1624,1600,1583],1); -ELEMENTS[5220] = Fluid2D([1698,1737,1716],1); -ELEMENTS[5221] = Fluid2D([1716,1737,1752],1); -ELEMENTS[5222] = Fluid2D([1752,1737,1774],1); -ELEMENTS[5223] = Fluid2D([1583,1600,1559],1); -ELEMENTS[5224] = Fluid2D([1583,1559,1542],1); -ELEMENTS[5225] = Fluid2D([1542,1559,1518],1); -ELEMENTS[5226] = Fluid2D([1542,1518,1499],1); -ELEMENTS[5227] = Fluid2D([1499,1518,1475],1); -ELEMENTS[5228] = Fluid2D([1499,1475,1456],1); -ELEMENTS[5229] = Fluid2D([1475,1518,1495],1); -ELEMENTS[5230] = Fluid2D([1456,1475,1430],1); -ELEMENTS[5231] = Fluid2D([1430,1475,1451],1); -ELEMENTS[5232] = Fluid2D([1451,1475,1495],1); -ELEMENTS[5233] = Fluid2D([1451,1495,1471],1); -ELEMENTS[5234] = Fluid2D([1471,1495,1515],1); -ELEMENTS[5235] = Fluid2D([1451,1471,1427],1); -ELEMENTS[5236] = Fluid2D([1427,1471,1447],1); -ELEMENTS[5237] = Fluid2D([1447,1471,1492],1); -ELEMENTS[5238] = Fluid2D([1492,1471,1515],1); -ELEMENTS[5239] = Fluid2D([1662,1624,1644],1); -ELEMENTS[5240] = Fluid2D([1644,1624,1605],1); -ELEMENTS[5241] = Fluid2D([1662,1644,1683],1); -ELEMENTS[5242] = Fluid2D([1683,1644,1665],1); -ELEMENTS[5243] = Fluid2D([1662,1683,1700],1); -ELEMENTS[5244] = Fluid2D([1665,1644,1626],1); -ELEMENTS[5245] = Fluid2D([1605,1624,1583],1); -ELEMENTS[5246] = Fluid2D([1605,1583,1563],1); -ELEMENTS[5247] = Fluid2D([1563,1583,1542],1); -ELEMENTS[5248] = Fluid2D([1563,1542,1521],1); -ELEMENTS[5249] = Fluid2D([1521,1542,1499],1); -ELEMENTS[5250] = Fluid2D([1521,1499,1478],1); -ELEMENTS[5251] = Fluid2D([1478,1499,1456],1); -ELEMENTS[5252] = Fluid2D([1478,1456,1436],1); -ELEMENTS[5253] = Fluid2D([1700,1683,1722],1); -ELEMENTS[5254] = Fluid2D([1626,1644,1605],1); -ELEMENTS[5255] = Fluid2D([1626,1605,1586],1); -ELEMENTS[5256] = Fluid2D([1626,1586,1610],1); -ELEMENTS[5257] = Fluid2D([1610,1586,1569],1); -ELEMENTS[5258] = Fluid2D([1586,1605,1563],1); -ELEMENTS[5259] = Fluid2D([1586,1563,1545],1); -ELEMENTS[5260] = Fluid2D([1569,1586,1545],1); -ELEMENTS[5261] = Fluid2D([1569,1545,1528],1); -ELEMENTS[5262] = Fluid2D([1545,1563,1521],1); -ELEMENTS[5263] = Fluid2D([1545,1521,1503],1); -ELEMENTS[5264] = Fluid2D([1528,1545,1503],1); -ELEMENTS[5265] = Fluid2D([1528,1503,1486],1); -ELEMENTS[5266] = Fluid2D([1503,1521,1478],1); -ELEMENTS[5267] = Fluid2D([1436,1456,1410],1); -ELEMENTS[5268] = Fluid2D([1436,1410,1390],1); -ELEMENTS[5269] = Fluid2D([1410,1456,1430],1); -ELEMENTS[5270] = Fluid2D([1410,1430,1383],1); -ELEMENTS[5271] = Fluid2D([1383,1430,1406],1); -ELEMENTS[5272] = Fluid2D([1406,1430,1451],1); -ELEMENTS[5273] = Fluid2D([1486,1503,1460],1); -ELEMENTS[5274] = Fluid2D([1486,1460,1443],1); -ELEMENTS[5275] = Fluid2D([1460,1503,1478],1); -ELEMENTS[5276] = Fluid2D([1460,1478,1436],1); -ELEMENTS[5277] = Fluid2D([1390,1410,1364],1); -ELEMENTS[5278] = Fluid2D([1390,1364,1344],1); -ELEMENTS[5279] = Fluid2D([1344,1364,1317],1); -ELEMENTS[5280] = Fluid2D([1317,1364,1337],1); -ELEMENTS[5281] = Fluid2D([1337,1364,1383],1); -ELEMENTS[5282] = Fluid2D([1364,1410,1383],1); -ELEMENTS[5283] = Fluid2D([1443,1460,1415],1); -ELEMENTS[5284] = Fluid2D([1443,1415,1398],1); -ELEMENTS[5285] = Fluid2D([1443,1398,1426],1); -ELEMENTS[5286] = Fluid2D([1426,1398,1380],1); -ELEMENTS[5287] = Fluid2D([1398,1415,1369],1); -ELEMENTS[5288] = Fluid2D([1369,1415,1390],1); -ELEMENTS[5289] = Fluid2D([1390,1415,1436],1); -ELEMENTS[5290] = Fluid2D([1380,1398,1351],1); -ELEMENTS[5291] = Fluid2D([1351,1398,1369],1); -ELEMENTS[5292] = Fluid2D([1436,1415,1460],1); -ELEMENTS[5293] = Fluid2D([1351,1369,1321],1); -ELEMENTS[5294] = Fluid2D([1351,1321,1304],1); -ELEMENTS[5295] = Fluid2D([1321,1369,1344],1); -ELEMENTS[5296] = Fluid2D([1344,1369,1390],1); -ELEMENTS[5297] = Fluid2D([1351,1304,1333],1); -ELEMENTS[5298] = Fluid2D([1304,1321,1272],1); -ELEMENTS[5299] = Fluid2D([1272,1321,1295],1); -ELEMENTS[5300] = Fluid2D([1295,1321,1344],1); -ELEMENTS[5301] = Fluid2D([1295,1344,1317],1); -ELEMENTS[5302] = Fluid2D([1351,1333,1380],1); -ELEMENTS[5303] = Fluid2D([1380,1333,1361],1); -ELEMENTS[5304] = Fluid2D([1361,1333,1313],1); -ELEMENTS[5305] = Fluid2D([1380,1361,1408],1); -ELEMENTS[5306] = Fluid2D([1408,1361,1387],1); -ELEMENTS[5307] = Fluid2D([1387,1361,1341],1); -ELEMENTS[5308] = Fluid2D([1272,1295,1243],1); -ELEMENTS[5309] = Fluid2D([1243,1295,1267],1); -ELEMENTS[5310] = Fluid2D([1267,1295,1317],1); -ELEMENTS[5311] = Fluid2D([1313,1333,1285],1); -ELEMENTS[5312] = Fluid2D([1285,1333,1304],1); -ELEMENTS[5313] = Fluid2D([1341,1361,1313],1); -ELEMENTS[5314] = Fluid2D([1341,1313,1282],1); -ELEMENTS[5315] = Fluid2D([1282,1313,1246],1); -ELEMENTS[5316] = Fluid2D([1282,1246,1211],1); -ELEMENTS[5317] = Fluid2D([1246,1313,1285],1); -ELEMENTS[5318] = Fluid2D([1246,1285,1217],1); -ELEMENTS[5319] = Fluid2D([1246,1217,1177],1); -ELEMENTS[5320] = Fluid2D([1217,1285,1255],1); -ELEMENTS[5321] = Fluid2D([1255,1285,1304],1); -ELEMENTS[5322] = Fluid2D([1255,1304,1272],1); -ELEMENTS[5323] = Fluid2D([1217,1255,1186],1); -ELEMENTS[5324] = Fluid2D([1217,1186,1142],1); -ELEMENTS[5325] = Fluid2D([1186,1255,1221],1); -ELEMENTS[5326] = Fluid2D([1221,1255,1272],1); -ELEMENTS[5327] = Fluid2D([1186,1221,1154],1); -ELEMENTS[5328] = Fluid2D([1186,1154,1104],1); -ELEMENTS[5329] = Fluid2D([1154,1221,1190],1); -ELEMENTS[5330] = Fluid2D([1190,1221,1243],1); -ELEMENTS[5331] = Fluid2D([1154,1190,1122],1); -ELEMENTS[5332] = Fluid2D([1122,1190,1161],1); -ELEMENTS[5333] = Fluid2D([1161,1190,1215],1); -ELEMENTS[5334] = Fluid2D([1215,1190,1243],1); -ELEMENTS[5335] = Fluid2D([1267,1317,1289],1); -ELEMENTS[5336] = Fluid2D([1289,1317,1337],1); -ELEMENTS[5337] = Fluid2D([1267,1289,1237],1); -ELEMENTS[5338] = Fluid2D([1267,1237,1215],1); -ELEMENTS[5339] = Fluid2D([1237,1289,1263],1); -ELEMENTS[5340] = Fluid2D([1263,1289,1312],1); -ELEMENTS[5341] = Fluid2D([1312,1289,1337],1); -ELEMENTS[5342] = Fluid2D([1312,1337,1360],1); -ELEMENTS[5343] = Fluid2D([1360,1337,1383],1); -ELEMENTS[5344] = Fluid2D([1360,1383,1406],1); -ELEMENTS[5345] = Fluid2D([1360,1406,1381],1); -ELEMENTS[5346] = Fluid2D([1381,1406,1427],1); -ELEMENTS[5347] = Fluid2D([1427,1406,1451],1); -ELEMENTS[5348] = Fluid2D([1243,1221,1272],1); -ELEMENTS[5349] = Fluid2D([1215,1237,1183],1); -ELEMENTS[5350] = Fluid2D([1215,1183,1161],1); -ELEMENTS[5351] = Fluid2D([1183,1237,1208],1); -ELEMENTS[5352] = Fluid2D([1208,1237,1263],1); -ELEMENTS[5353] = Fluid2D([1183,1208,1153],1); -ELEMENTS[5354] = Fluid2D([1183,1153,1128],1); -ELEMENTS[5355] = Fluid2D([1153,1208,1180],1); -ELEMENTS[5356] = Fluid2D([1180,1208,1234],1); -ELEMENTS[5357] = Fluid2D([1234,1208,1263],1); -ELEMENTS[5358] = Fluid2D([1161,1183,1128],1); -ELEMENTS[5359] = Fluid2D([1161,1128,1084],1); -ELEMENTS[5360] = Fluid2D([1084,1128,1036],1); -ELEMENTS[5361] = Fluid2D([1084,1036,987],1); -ELEMENTS[5362] = Fluid2D([1036,1128,1094],1); -ELEMENTS[5363] = Fluid2D([1094,1128,1153],1); -ELEMENTS[5364] = Fluid2D([1036,1094,1003],1); -ELEMENTS[5365] = Fluid2D([1036,1003,948],1); -ELEMENTS[5366] = Fluid2D([1003,1094,1053],1); -ELEMENTS[5367] = Fluid2D([1053,1094,1124],1); -ELEMENTS[5368] = Fluid2D([1003,1053,964],1); -ELEMENTS[5369] = Fluid2D([964,1053,1018],1); -ELEMENTS[5370] = Fluid2D([1018,1053,1087],1); -ELEMENTS[5371] = Fluid2D([1124,1094,1153],1); -ELEMENTS[5372] = Fluid2D([1124,1153,1180],1); -ELEMENTS[5373] = Fluid2D([1087,1053,1124],1); -ELEMENTS[5374] = Fluid2D([1087,1124,1148],1); -ELEMENTS[5375] = Fluid2D([1148,1124,1180],1); -ELEMENTS[5376] = Fluid2D([1148,1180,1204],1); -ELEMENTS[5377] = Fluid2D([1204,1180,1234],1); -ELEMENTS[5378] = Fluid2D([1204,1234,1257],1); -ELEMENTS[5379] = Fluid2D([1257,1234,1286],1); -ELEMENTS[5380] = Fluid2D([1257,1286,1307],1); -ELEMENTS[5381] = Fluid2D([1286,1234,1263],1); -ELEMENTS[5382] = Fluid2D([1148,1204,1174],1); -ELEMENTS[5383] = Fluid2D([1174,1204,1228],1); -ELEMENTS[5384] = Fluid2D([1148,1174,1114],1); -ELEMENTS[5385] = Fluid2D([1114,1174,1145],1); -ELEMENTS[5386] = Fluid2D([1145,1174,1202],1); -ELEMENTS[5387] = Fluid2D([1228,1204,1257],1); -ELEMENTS[5388] = Fluid2D([1202,1174,1228],1); -ELEMENTS[5389] = Fluid2D([1202,1228,1254],1); -ELEMENTS[5390] = Fluid2D([1254,1228,1280],1); -ELEMENTS[5391] = Fluid2D([1254,1280,1303],1); -ELEMENTS[5392] = Fluid2D([1280,1228,1257],1); -ELEMENTS[5393] = Fluid2D([1303,1280,1330],1); -ELEMENTS[5394] = Fluid2D([1330,1280,1307],1); -ELEMENTS[5395] = Fluid2D([1307,1280,1257],1); -ELEMENTS[5396] = Fluid2D([1307,1286,1334],1); -ELEMENTS[5397] = Fluid2D([1307,1334,1355],1); -ELEMENTS[5398] = Fluid2D([1334,1286,1312],1); -ELEMENTS[5399] = Fluid2D([1312,1286,1263],1); -ELEMENTS[5400] = Fluid2D([1307,1355,1330],1); -ELEMENTS[5401] = Fluid2D([1330,1355,1377],1); -ELEMENTS[5402] = Fluid2D([1377,1355,1402],1); -ELEMENTS[5403] = Fluid2D([1402,1355,1381],1); -ELEMENTS[5404] = Fluid2D([1381,1355,1334],1); -ELEMENTS[5405] = Fluid2D([1330,1377,1352],1); -ELEMENTS[5406] = Fluid2D([1352,1377,1399],1); -ELEMENTS[5407] = Fluid2D([1330,1352,1303],1); -ELEMENTS[5408] = Fluid2D([1303,1352,1326],1); -ELEMENTS[5409] = Fluid2D([1326,1352,1374],1); -ELEMENTS[5410] = Fluid2D([1399,1377,1422],1); -ELEMENTS[5411] = Fluid2D([1422,1377,1402],1); -ELEMENTS[5412] = Fluid2D([1374,1352,1399],1); -ELEMENTS[5413] = Fluid2D([1422,1402,1447],1); -ELEMENTS[5414] = Fluid2D([1422,1447,1466],1); -ELEMENTS[5415] = Fluid2D([1447,1402,1427],1); -ELEMENTS[5416] = Fluid2D([1427,1402,1381],1); -ELEMENTS[5417] = Fluid2D([1466,1447,1492],1); -ELEMENTS[5418] = Fluid2D([1466,1492,1511],1); -ELEMENTS[5419] = Fluid2D([1466,1511,1489],1); -ELEMENTS[5420] = Fluid2D([1489,1511,1531],1); -ELEMENTS[5421] = Fluid2D([1466,1489,1444],1); -ELEMENTS[5422] = Fluid2D([1444,1489,1463],1); -ELEMENTS[5423] = Fluid2D([1463,1489,1506],1); -ELEMENTS[5424] = Fluid2D([1531,1511,1553],1); -ELEMENTS[5425] = Fluid2D([1506,1489,1531],1); -ELEMENTS[5426] = Fluid2D([1506,1531,1548],1); -ELEMENTS[5427] = Fluid2D([1506,1548,1526],1); -ELEMENTS[5428] = Fluid2D([1381,1334,1360],1); -ELEMENTS[5429] = Fluid2D([1360,1334,1312],1); -ELEMENTS[5430] = Fluid2D([1904,1918,1885],1); -ELEMENTS[5431] = Fluid2D([1904,1885,1871],1); -ELEMENTS[5432] = Fluid2D([1871,1885,1851],1); -ELEMENTS[5433] = Fluid2D([1851,1885,1866],1); -ELEMENTS[5434] = Fluid2D([1851,1866,1830],1); -ELEMENTS[5435] = Fluid2D([1904,1871,1891],1); -ELEMENTS[5436] = Fluid2D([1904,1891,1926],1); -ELEMENTS[5437] = Fluid2D([1904,1926,1938],1); -ELEMENTS[5438] = Fluid2D([1938,1926,1960],1); -ELEMENTS[5439] = Fluid2D([1938,1960,1970],1); -ELEMENTS[5440] = Fluid2D([1970,1960,1992],1); -ELEMENTS[5441] = Fluid2D([1891,1871,1859],1); -ELEMENTS[5442] = Fluid2D([1859,1871,1837],1); -ELEMENTS[5443] = Fluid2D([1837,1871,1851],1); -ELEMENTS[5444] = Fluid2D([1837,1851,1815],1); -ELEMENTS[5445] = Fluid2D([1837,1815,1800],1); -ELEMENTS[5446] = Fluid2D([1800,1815,1778],1); -ELEMENTS[5447] = Fluid2D([1778,1815,1794],1); -ELEMENTS[5448] = Fluid2D([1815,1851,1830],1); -ELEMENTS[5449] = Fluid2D([1794,1815,1830],1); -ELEMENTS[5450] = Fluid2D([1778,1794,1755],1); -ELEMENTS[5451] = Fluid2D([1778,1755,1741],1); -ELEMENTS[5452] = Fluid2D([1741,1755,1718],1); -ELEMENTS[5453] = Fluid2D([1741,1718,1703],1); -ELEMENTS[5454] = Fluid2D([1703,1718,1680],1); -ELEMENTS[5455] = Fluid2D([1680,1718,1697],1); -ELEMENTS[5456] = Fluid2D([1703,1680,1663],1); -ELEMENTS[5457] = Fluid2D([1703,1663,1686],1); -ELEMENTS[5458] = Fluid2D([1663,1680,1641],1); -ELEMENTS[5459] = Fluid2D([1641,1680,1660],1); -ELEMENTS[5460] = Fluid2D([1686,1663,1647],1); -ELEMENTS[5461] = Fluid2D([1660,1680,1697],1); -ELEMENTS[5462] = Fluid2D([1647,1663,1625],1); -ELEMENTS[5463] = Fluid2D([1647,1625,1608],1); -ELEMENTS[5464] = Fluid2D([1625,1663,1641],1); -ELEMENTS[5465] = Fluid2D([1608,1625,1585],1); -ELEMENTS[5466] = Fluid2D([1585,1625,1601],1); -ELEMENTS[5467] = Fluid2D([1601,1625,1641],1); -ELEMENTS[5468] = Fluid2D([1608,1585,1570],1); -ELEMENTS[5469] = Fluid2D([1608,1570,1597],1); -ELEMENTS[5470] = Fluid2D([1570,1585,1544],1); -ELEMENTS[5471] = Fluid2D([1544,1585,1560],1); -ELEMENTS[5472] = Fluid2D([1560,1585,1601],1); -ELEMENTS[5473] = Fluid2D([1597,1570,1556],1); -ELEMENTS[5474] = Fluid2D([1597,1556,1581],1); -ELEMENTS[5475] = Fluid2D([1556,1570,1529],1); -ELEMENTS[5476] = Fluid2D([1556,1529,1514],1); -ELEMENTS[5477] = Fluid2D([1529,1570,1544],1); -ELEMENTS[5478] = Fluid2D([1514,1529,1488],1); -ELEMENTS[5479] = Fluid2D([1488,1529,1502],1); -ELEMENTS[5480] = Fluid2D([1502,1529,1544],1); -ELEMENTS[5481] = Fluid2D([1502,1544,1519],1); -ELEMENTS[5482] = Fluid2D([1519,1544,1560],1); -ELEMENTS[5483] = Fluid2D([1502,1519,1476],1); -ELEMENTS[5484] = Fluid2D([1476,1519,1496],1); -ELEMENTS[5485] = Fluid2D([1496,1519,1537],1); -ELEMENTS[5486] = Fluid2D([1537,1519,1560],1); -ELEMENTS[5487] = Fluid2D([1537,1560,1580],1); -ELEMENTS[5488] = Fluid2D([1537,1580,1554],1); -ELEMENTS[5489] = Fluid2D([1580,1560,1601],1); -ELEMENTS[5490] = Fluid2D([1554,1580,1595],1); -ELEMENTS[5491] = Fluid2D([1595,1580,1620],1); -ELEMENTS[5492] = Fluid2D([1620,1580,1601],1); -ELEMENTS[5493] = Fluid2D([1620,1601,1641],1); -ELEMENTS[5494] = Fluid2D([1620,1641,1660],1); -ELEMENTS[5495] = Fluid2D([1620,1660,1635],1); -ELEMENTS[5496] = Fluid2D([1635,1660,1675],1); -ELEMENTS[5497] = Fluid2D([1675,1660,1697],1); -ELEMENTS[5498] = Fluid2D([1635,1675,1649],1); -ELEMENTS[5499] = Fluid2D([1635,1649,1610],1); -ELEMENTS[5500] = Fluid2D([1635,1610,1595],1); -ELEMENTS[5501] = Fluid2D([1595,1610,1569],1); -ELEMENTS[5502] = Fluid2D([1595,1569,1554],1); -ELEMENTS[5503] = Fluid2D([1554,1569,1528],1); -ELEMENTS[5504] = Fluid2D([1554,1528,1512],1); -ELEMENTS[5505] = Fluid2D([1512,1528,1486],1); -ELEMENTS[5506] = Fluid2D([1610,1649,1626],1); -ELEMENTS[5507] = Fluid2D([1626,1649,1665],1); -ELEMENTS[5508] = Fluid2D([1778,1741,1763],1); -ELEMENTS[5509] = Fluid2D([1763,1741,1724],1); -ELEMENTS[5510] = Fluid2D([1724,1741,1703],1); -ELEMENTS[5511] = Fluid2D([1724,1703,1686],1); -ELEMENTS[5512] = Fluid2D([1724,1686,1704],1); -ELEMENTS[5513] = Fluid2D([1778,1763,1800],1); -ELEMENTS[5514] = Fluid2D([1512,1486,1470],1); -ELEMENTS[5515] = Fluid2D([1470,1486,1443],1); -ELEMENTS[5516] = Fluid2D([1800,1763,1790],1); -ELEMENTS[5517] = Fluid2D([1790,1763,1756],1); -ELEMENTS[5518] = Fluid2D([1800,1790,1825],1); -ELEMENTS[5519] = Fluid2D([1800,1825,1837],1); -ELEMENTS[5520] = Fluid2D([1825,1790,1802],1); -ELEMENTS[5521] = Fluid2D([1802,1790,1756],1); -ELEMENTS[5522] = Fluid2D([1837,1825,1859],1); -ELEMENTS[5523] = Fluid2D([1470,1443,1426],1); -ELEMENTS[5524] = Fluid2D([1470,1426,1453],1); -ELEMENTS[5525] = Fluid2D([1470,1453,1496],1); -ELEMENTS[5526] = Fluid2D([1453,1426,1408],1); -ELEMENTS[5527] = Fluid2D([1408,1426,1380],1); -ELEMENTS[5528] = Fluid2D([1496,1453,1476],1); -ELEMENTS[5529] = Fluid2D([1476,1453,1432],1); -ELEMENTS[5530] = Fluid2D([1432,1453,1408],1); -ELEMENTS[5531] = Fluid2D([1476,1432,1459],1); -ELEMENTS[5532] = Fluid2D([1459,1432,1414],1); -ELEMENTS[5533] = Fluid2D([1414,1432,1387],1); -ELEMENTS[5534] = Fluid2D([1432,1408,1387],1); -ELEMENTS[5535] = Fluid2D([1859,1825,1847],1); -ELEMENTS[5536] = Fluid2D([1847,1825,1802],1); -ELEMENTS[5537] = Fluid2D([1847,1802,1832],1); -ELEMENTS[5538] = Fluid2D([1832,1802,1797],1); -ELEMENTS[5539] = Fluid2D([1459,1414,1445],1); -ELEMENTS[5540] = Fluid2D([1459,1445,1488],1); -ELEMENTS[5541] = Fluid2D([1488,1445,1472],1); -ELEMENTS[5542] = Fluid2D([1459,1488,1502],1); -ELEMENTS[5543] = Fluid2D([1459,1502,1476],1); -ELEMENTS[5544] = Fluid2D([1472,1445,1428],1); -ELEMENTS[5545] = Fluid2D([1428,1445,1400],1); -ELEMENTS[5546] = Fluid2D([1428,1400,1384],1); -ELEMENTS[5547] = Fluid2D([1400,1445,1414],1); -ELEMENTS[5548] = Fluid2D([1400,1414,1368],1); -ELEMENTS[5549] = Fluid2D([1400,1368,1353],1); -ELEMENTS[5550] = Fluid2D([1368,1414,1387],1); -ELEMENTS[5551] = Fluid2D([1368,1387,1341],1); -ELEMENTS[5552] = Fluid2D([1353,1368,1320],1); -ELEMENTS[5553] = Fluid2D([1320,1368,1341],1); -ELEMENTS[5554] = Fluid2D([1353,1320,1305],1); -ELEMENTS[5555] = Fluid2D([1384,1400,1353],1); -ELEMENTS[5556] = Fluid2D([1384,1353,1335],1); -ELEMENTS[5557] = Fluid2D([1686,1647,1667],1); -ELEMENTS[5558] = Fluid2D([1686,1667,1704],1); -ELEMENTS[5559] = Fluid2D([1667,1647,1638],1); -ELEMENTS[5560] = Fluid2D([1667,1638,1664],1); -ELEMENTS[5561] = Fluid2D([1638,1647,1608],1); -ELEMENTS[5562] = Fluid2D([1664,1638,1623],1); -ELEMENTS[5563] = Fluid2D([1638,1608,1597],1); -ELEMENTS[5564] = Fluid2D([1638,1597,1623],1); -ELEMENTS[5565] = Fluid2D([1463,1506,1483],1); -ELEMENTS[5566] = Fluid2D([1483,1506,1526],1); -ELEMENTS[5567] = Fluid2D([1463,1483,1440],1); -ELEMENTS[5568] = Fluid2D([1440,1483,1461],1); -ELEMENTS[5569] = Fluid2D([1461,1483,1504],1); -ELEMENTS[5570] = Fluid2D([1440,1461,1417],1); -ELEMENTS[5571] = Fluid2D([1417,1461,1439],1); -ELEMENTS[5572] = Fluid2D([1439,1461,1482],1); -ELEMENTS[5573] = Fluid2D([1504,1483,1526],1); -ELEMENTS[5574] = Fluid2D([1504,1526,1546],1); -ELEMENTS[5575] = Fluid2D([1504,1546,1525],1); -ELEMENTS[5576] = Fluid2D([1525,1546,1567],1); -ELEMENTS[5577] = Fluid2D([1504,1525,1482],1); -ELEMENTS[5578] = Fluid2D([1482,1525,1505],1); -ELEMENTS[5579] = Fluid2D([1505,1525,1547],1); -ELEMENTS[5580] = Fluid2D([1525,1567,1547],1); -ELEMENTS[5581] = Fluid2D([1547,1567,1589],1); -ELEMENTS[5582] = Fluid2D([1547,1589,1572],1); -ELEMENTS[5583] = Fluid2D([1572,1589,1612],1); -ELEMENTS[5584] = Fluid2D([1612,1589,1629],1); -ELEMENTS[5585] = Fluid2D([1589,1567,1607],1); -ELEMENTS[5586] = Fluid2D([1589,1607,1629],1); -ELEMENTS[5587] = Fluid2D([1482,1461,1504],1); -ELEMENTS[5588] = Fluid2D([1463,1440,1419],1); -ELEMENTS[5589] = Fluid2D([1419,1440,1395],1); -ELEMENTS[5590] = Fluid2D([1395,1440,1417],1); -ELEMENTS[5591] = Fluid2D([1395,1417,1372],1); -ELEMENTS[5592] = Fluid2D([1395,1372,1348],1); -ELEMENTS[5593] = Fluid2D([1372,1417,1394],1); -ELEMENTS[5594] = Fluid2D([1394,1417,1439],1); -ELEMENTS[5595] = Fluid2D([1394,1439,1418],1); -ELEMENTS[5596] = Fluid2D([1418,1439,1462],1); -ELEMENTS[5597] = Fluid2D([1348,1372,1323],1); -ELEMENTS[5598] = Fluid2D([1323,1372,1347],1); -ELEMENTS[5599] = Fluid2D([1347,1372,1394],1); -ELEMENTS[5600] = Fluid2D([1347,1394,1373],1); -ELEMENTS[5601] = Fluid2D([1373,1394,1418],1); -ELEMENTS[5602] = Fluid2D([1373,1418,1397],1); -ELEMENTS[5603] = Fluid2D([1397,1418,1442],1); -ELEMENTS[5604] = Fluid2D([1442,1418,1462],1); -ELEMENTS[5605] = Fluid2D([1442,1462,1487],1); -ELEMENTS[5606] = Fluid2D([1487,1462,1505],1); -ELEMENTS[5607] = Fluid2D([1505,1462,1482],1); -ELEMENTS[5608] = Fluid2D([1482,1462,1439],1); -ELEMENTS[5609] = Fluid2D([1463,1419,1444],1); -ELEMENTS[5610] = Fluid2D([1444,1419,1399],1); -ELEMENTS[5611] = Fluid2D([1399,1419,1374],1); -ELEMENTS[5612] = Fluid2D([1444,1399,1422],1); -ELEMENTS[5613] = Fluid2D([1374,1419,1395],1); -ELEMENTS[5614] = Fluid2D([1374,1395,1348],1); -ELEMENTS[5615] = Fluid2D([1374,1348,1326],1); -ELEMENTS[5616] = Fluid2D([1326,1348,1300],1); -ELEMENTS[5617] = Fluid2D([1326,1300,1276],1); -ELEMENTS[5618] = Fluid2D([1326,1276,1303],1); -ELEMENTS[5619] = Fluid2D([1303,1276,1254],1); -ELEMENTS[5620] = Fluid2D([1254,1276,1224],1); -ELEMENTS[5621] = Fluid2D([1224,1276,1251],1); -ELEMENTS[5622] = Fluid2D([1251,1276,1300],1); -ELEMENTS[5623] = Fluid2D([1300,1348,1323],1); -ELEMENTS[5624] = Fluid2D([1300,1323,1273],1); -ELEMENTS[5625] = Fluid2D([1273,1323,1299],1); -ELEMENTS[5626] = Fluid2D([1299,1323,1347],1); -ELEMENTS[5627] = Fluid2D([1299,1347,1324],1); -ELEMENTS[5628] = Fluid2D([1324,1347,1373],1); -ELEMENTS[5629] = Fluid2D([1324,1373,1350],1); -ELEMENTS[5630] = Fluid2D([1350,1373,1397],1); -ELEMENTS[5631] = Fluid2D([1350,1397,1375],1); -ELEMENTS[5632] = Fluid2D([1375,1397,1420],1); -ELEMENTS[5633] = Fluid2D([1273,1299,1250],1); -ELEMENTS[5634] = Fluid2D([1250,1299,1275],1); -ELEMENTS[5635] = Fluid2D([1275,1299,1324],1); -ELEMENTS[5636] = Fluid2D([1420,1397,1442],1); -ELEMENTS[5637] = Fluid2D([1420,1442,1464],1); -ELEMENTS[5638] = Fluid2D([1464,1442,1487],1); -ELEMENTS[5639] = Fluid2D([1464,1487,1508],1); -ELEMENTS[5640] = Fluid2D([1508,1487,1530],1); -ELEMENTS[5641] = Fluid2D([1530,1487,1505],1); -ELEMENTS[5642] = Fluid2D([1530,1505,1547],1); -ELEMENTS[5643] = Fluid2D([1530,1547,1572],1); -ELEMENTS[5644] = Fluid2D([1530,1572,1552],1); -ELEMENTS[5645] = Fluid2D([1552,1572,1592],1); -ELEMENTS[5646] = Fluid2D([1592,1572,1612],1); -ELEMENTS[5647] = Fluid2D([1464,1508,1490],1); -ELEMENTS[5648] = Fluid2D([1490,1508,1532],1); -ELEMENTS[5649] = Fluid2D([1464,1490,1446],1); -ELEMENTS[5650] = Fluid2D([1446,1490,1469],1); -ELEMENTS[5651] = Fluid2D([1469,1490,1513],1); -ELEMENTS[5652] = Fluid2D([1532,1508,1552],1); -ELEMENTS[5653] = Fluid2D([1552,1508,1530],1); -ELEMENTS[5654] = Fluid2D([1513,1490,1532],1); -ELEMENTS[5655] = Fluid2D([1513,1532,1555],1); -ELEMENTS[5656] = Fluid2D([1555,1532,1574],1); -ELEMENTS[5657] = Fluid2D([1574,1532,1552],1); -ELEMENTS[5658] = Fluid2D([1513,1555,1535],1); -ELEMENTS[5659] = Fluid2D([1535,1555,1576],1); -ELEMENTS[5660] = Fluid2D([1576,1555,1596],1); -ELEMENTS[5661] = Fluid2D([1596,1555,1574],1); -ELEMENTS[5662] = Fluid2D([1596,1574,1614],1); -ELEMENTS[5663] = Fluid2D([1614,1574,1592],1); -ELEMENTS[5664] = Fluid2D([1592,1574,1552],1); -ELEMENTS[5665] = Fluid2D([1251,1300,1273],1); -ELEMENTS[5666] = Fluid2D([1251,1273,1222],1); -ELEMENTS[5667] = Fluid2D([1251,1222,1199],1); -ELEMENTS[5668] = Fluid2D([1251,1199,1224],1); -ELEMENTS[5669] = Fluid2D([1224,1199,1168],1); -ELEMENTS[5670] = Fluid2D([1168,1199,1139],1); -ELEMENTS[5671] = Fluid2D([1139,1199,1166],1); -ELEMENTS[5672] = Fluid2D([1166,1199,1222],1); -ELEMENTS[5673] = Fluid2D([1222,1273,1250],1); -ELEMENTS[5674] = Fluid2D([1222,1250,1196],1); -ELEMENTS[5675] = Fluid2D([1222,1196,1166],1); -ELEMENTS[5676] = Fluid2D([1196,1250,1223],1); -ELEMENTS[5677] = Fluid2D([1223,1250,1275],1); -ELEMENTS[5678] = Fluid2D([1223,1275,1253],1); -ELEMENTS[5679] = Fluid2D([1253,1275,1302],1); -ELEMENTS[5680] = Fluid2D([1196,1223,1167],1); -ELEMENTS[5681] = Fluid2D([1167,1223,1201],1); -ELEMENTS[5682] = Fluid2D([1201,1223,1253],1); -ELEMENTS[5683] = Fluid2D([1302,1275,1324],1); -ELEMENTS[5684] = Fluid2D([1302,1324,1350],1); -ELEMENTS[5685] = Fluid2D([1166,1196,1138],1); -ELEMENTS[5686] = Fluid2D([1166,1138,1108],1); -ELEMENTS[5687] = Fluid2D([1138,1196,1167],1); -ELEMENTS[5688] = Fluid2D([1138,1167,1110],1); -ELEMENTS[5689] = Fluid2D([1110,1167,1144],1); -ELEMENTS[5690] = Fluid2D([1144,1167,1201],1); -ELEMENTS[5691] = Fluid2D([1144,1201,1171],1); -ELEMENTS[5692] = Fluid2D([1171,1201,1227],1); -ELEMENTS[5693] = Fluid2D([1110,1144,1082],1); -ELEMENTS[5694] = Fluid2D([1082,1144,1112],1); -ELEMENTS[5695] = Fluid2D([1112,1144,1171],1); -ELEMENTS[5696] = Fluid2D([1112,1171,1147],1); -ELEMENTS[5697] = Fluid2D([1147,1171,1203],1); -ELEMENTS[5698] = Fluid2D([1227,1201,1253],1); -ELEMENTS[5699] = Fluid2D([1203,1171,1227],1); -ELEMENTS[5700] = Fluid2D([1203,1227,1256],1); -ELEMENTS[5701] = Fluid2D([1256,1227,1278],1); -ELEMENTS[5702] = Fluid2D([1256,1278,1306],1); -ELEMENTS[5703] = Fluid2D([1278,1227,1253],1); -ELEMENTS[5704] = Fluid2D([1306,1278,1328],1); -ELEMENTS[5705] = Fluid2D([1328,1278,1302],1); -ELEMENTS[5706] = Fluid2D([1302,1278,1253],1); -ELEMENTS[5707] = Fluid2D([1108,1138,1077],1); -ELEMENTS[5708] = Fluid2D([1108,1077,1035],1); -ELEMENTS[5709] = Fluid2D([1077,1138,1110],1); -ELEMENTS[5710] = Fluid2D([1077,1110,1037],1); -ELEMENTS[5711] = Fluid2D([1037,1110,1082],1); -ELEMENTS[5712] = Fluid2D([1037,1082,1010],1); -ELEMENTS[5713] = Fluid2D([1037,1010,972],1); -ELEMENTS[5714] = Fluid2D([1010,1082,1041],1); -ELEMENTS[5715] = Fluid2D([1041,1082,1112],1); -ELEMENTS[5716] = Fluid2D([1041,1112,1085],1); -ELEMENTS[5717] = Fluid2D([1085,1112,1147],1); -ELEMENTS[5718] = Fluid2D([1085,1147,1119],1); -ELEMENTS[5719] = Fluid2D([1119,1147,1178],1); -ELEMENTS[5720] = Fluid2D([1035,1077,1006],1); -ELEMENTS[5721] = Fluid2D([1006,1077,1037],1); -ELEMENTS[5722] = Fluid2D([1006,1037,972],1); -ELEMENTS[5723] = Fluid2D([972,1010,939],1); -ELEMENTS[5724] = Fluid2D([972,939,903],1); -ELEMENTS[5725] = Fluid2D([939,1010,975],1); -ELEMENTS[5726] = Fluid2D([975,1010,1041],1); -ELEMENTS[5727] = Fluid2D([1178,1147,1203],1); -ELEMENTS[5728] = Fluid2D([1178,1203,1231],1); -ELEMENTS[5729] = Fluid2D([1231,1203,1256],1); -ELEMENTS[5730] = Fluid2D([1231,1256,1284],1); -ELEMENTS[5731] = Fluid2D([1284,1256,1306],1); -ELEMENTS[5732] = Fluid2D([1284,1306,1332],1); -ELEMENTS[5733] = Fluid2D([1332,1306,1354],1); -ELEMENTS[5734] = Fluid2D([1332,1354,1379],1); -ELEMENTS[5735] = Fluid2D([1354,1306,1328],1); -ELEMENTS[5736] = Fluid2D([1379,1354,1401],1); -ELEMENTS[5737] = Fluid2D([1401,1354,1375],1); -ELEMENTS[5738] = Fluid2D([1375,1354,1328],1); -ELEMENTS[5739] = Fluid2D([1375,1328,1350],1); -ELEMENTS[5740] = Fluid2D([1350,1328,1302],1); -ELEMENTS[5741] = Fluid2D([903,939,869],1); -ELEMENTS[5742] = Fluid2D([903,869,836],1); -ELEMENTS[5743] = Fluid2D([836,869,805],1); -ELEMENTS[5744] = Fluid2D([836,805,771],1); -ELEMENTS[5745] = Fluid2D([805,869,839],1); -ELEMENTS[5746] = Fluid2D([839,869,906],1); -ELEMENTS[5747] = Fluid2D([906,869,939],1); -ELEMENTS[5748] = Fluid2D([906,939,975],1); -ELEMENTS[5749] = Fluid2D([906,975,944],1); -ELEMENTS[5750] = Fluid2D([944,975,1017],1); -ELEMENTS[5751] = Fluid2D([1017,975,1041],1); -ELEMENTS[5752] = Fluid2D([1017,1041,1085],1); -ELEMENTS[5753] = Fluid2D([944,1017,981],1); -ELEMENTS[5754] = Fluid2D([981,1017,1050],1); -ELEMENTS[5755] = Fluid2D([944,981,910],1); -ELEMENTS[5756] = Fluid2D([910,981,950],1); -ELEMENTS[5757] = Fluid2D([950,981,1020],1); -ELEMENTS[5758] = Fluid2D([1050,1017,1085],1); -ELEMENTS[5759] = Fluid2D([1020,981,1050],1); -ELEMENTS[5760] = Fluid2D([1020,1050,1091],1); -ELEMENTS[5761] = Fluid2D([1091,1050,1119],1); -ELEMENTS[5762] = Fluid2D([1091,1119,1150],1); -ELEMENTS[5763] = Fluid2D([1119,1050,1085],1); -ELEMENTS[5764] = Fluid2D([1150,1119,1178],1); -ELEMENTS[5765] = Fluid2D([1150,1178,1205],1); -ELEMENTS[5766] = Fluid2D([1205,1178,1231],1); -ELEMENTS[5767] = Fluid2D([1205,1231,1259],1); -ELEMENTS[5768] = Fluid2D([1259,1231,1284],1); -ELEMENTS[5769] = Fluid2D([1259,1284,1308],1); -ELEMENTS[5770] = Fluid2D([1308,1284,1332],1); -ELEMENTS[5771] = Fluid2D([771,805,741],1); -ELEMENTS[5772] = Fluid2D([771,741,692],1); -ELEMENTS[5773] = Fluid2D([741,805,775],1); -ELEMENTS[5774] = Fluid2D([775,805,839],1); -ELEMENTS[5775] = Fluid2D([741,775,710],1); -ELEMENTS[5776] = Fluid2D([710,775,745],1); -ELEMENTS[5777] = Fluid2D([745,775,807],1); -ELEMENTS[5778] = Fluid2D([807,775,839],1); -ELEMENTS[5779] = Fluid2D([807,839,875],1); -ELEMENTS[5780] = Fluid2D([875,839,906],1); -ELEMENTS[5781] = Fluid2D([807,875,842],1); -ELEMENTS[5782] = Fluid2D([842,875,910],1); -ELEMENTS[5783] = Fluid2D([910,875,944],1); -ELEMENTS[5784] = Fluid2D([944,875,906],1); -ELEMENTS[5785] = Fluid2D([807,842,778],1); -ELEMENTS[5786] = Fluid2D([778,842,814],1); -ELEMENTS[5787] = Fluid2D([814,842,879],1); -ELEMENTS[5788] = Fluid2D([778,814,748],1); -ELEMENTS[5789] = Fluid2D([748,814,784],1); -ELEMENTS[5790] = Fluid2D([784,814,849],1); -ELEMENTS[5791] = Fluid2D([879,842,910],1); -ELEMENTS[5792] = Fluid2D([879,910,950],1); -ELEMENTS[5793] = Fluid2D([849,814,879],1); -ELEMENTS[5794] = Fluid2D([849,879,919],1); -ELEMENTS[5795] = Fluid2D([919,879,950],1); -ELEMENTS[5796] = Fluid2D([919,950,989],1); -ELEMENTS[5797] = Fluid2D([692,741,665],1); -ELEMENTS[5798] = Fluid2D([692,665,615],1); -ELEMENTS[5799] = Fluid2D([665,741,710],1); -ELEMENTS[5800] = Fluid2D([665,710,638],1); -ELEMENTS[5801] = Fluid2D([665,638,590],1); -ELEMENTS[5802] = Fluid2D([638,710,682],1); -ELEMENTS[5803] = Fluid2D([682,710,745],1); -ELEMENTS[5804] = Fluid2D([682,745,715],1); -ELEMENTS[5805] = Fluid2D([715,745,778],1); -ELEMENTS[5806] = Fluid2D([638,682,612],1); -ELEMENTS[5807] = Fluid2D([612,682,655],1); -ELEMENTS[5808] = Fluid2D([655,682,715],1); -ELEMENTS[5809] = Fluid2D([989,950,1020],1); -ELEMENTS[5810] = Fluid2D([989,1020,1059],1); -ELEMENTS[5811] = Fluid2D([989,1059,1028],1); -ELEMENTS[5812] = Fluid2D([1028,1059,1098],1); -ELEMENTS[5813] = Fluid2D([1098,1059,1127],1); -ELEMENTS[5814] = Fluid2D([1127,1059,1091],1); -ELEMENTS[5815] = Fluid2D([1091,1059,1020],1); -ELEMENTS[5816] = Fluid2D([778,745,807],1); -ELEMENTS[5817] = Fluid2D([1254,1224,1202],1); -ELEMENTS[5818] = Fluid2D([1202,1224,1168],1); -ELEMENTS[5819] = Fluid2D([1202,1168,1145],1); -ELEMENTS[5820] = Fluid2D([1145,1168,1111],1); -ELEMENTS[5821] = Fluid2D([1145,1111,1083],1); -ELEMENTS[5822] = Fluid2D([1083,1111,1038],1); -ELEMENTS[5823] = Fluid2D([1083,1038,1013],1); -ELEMENTS[5824] = Fluid2D([1038,1111,1078],1); -ELEMENTS[5825] = Fluid2D([1078,1111,1139],1); -ELEMENTS[5826] = Fluid2D([1111,1168,1139],1); -ELEMENTS[5827] = Fluid2D([1013,1038,973],1); -ELEMENTS[5828] = Fluid2D([1013,973,941],1); -ELEMENTS[5829] = Fluid2D([973,1038,1008],1); -ELEMENTS[5830] = Fluid2D([1008,1038,1078],1); -ELEMENTS[5831] = Fluid2D([1013,941,976],1); -ELEMENTS[5832] = Fluid2D([976,941,892],1); -ELEMENTS[5833] = Fluid2D([892,941,855],1); -ELEMENTS[5834] = Fluid2D([855,941,905],1); -ELEMENTS[5835] = Fluid2D([905,941,973],1); -ELEMENTS[5836] = Fluid2D([1008,1078,1035],1); -ELEMENTS[5837] = Fluid2D([1035,1078,1108],1); -ELEMENTS[5838] = Fluid2D([1108,1078,1139],1); -ELEMENTS[5839] = Fluid2D([1108,1139,1166],1); -ELEMENTS[5840] = Fluid2D([905,973,936],1); -ELEMENTS[5841] = Fluid2D([905,936,866],1); -ELEMENTS[5842] = Fluid2D([866,936,902],1); -ELEMENTS[5843] = Fluid2D([902,936,971],1); -ELEMENTS[5844] = Fluid2D([866,902,834],1); -ELEMENTS[5845] = Fluid2D([834,902,865],1); -ELEMENTS[5846] = Fluid2D([865,902,935],1); -ELEMENTS[5847] = Fluid2D([935,902,971],1); -ELEMENTS[5848] = Fluid2D([935,971,1006],1); -ELEMENTS[5849] = Fluid2D([971,936,1008],1); -ELEMENTS[5850] = Fluid2D([1008,936,973],1); -ELEMENTS[5851] = Fluid2D([1008,1035,971],1); -ELEMENTS[5852] = Fluid2D([971,1035,1006],1); -ELEMENTS[5853] = Fluid2D([1013,976,1043],1); -ELEMENTS[5854] = Fluid2D([1013,1043,1083],1); -ELEMENTS[5855] = Fluid2D([1043,976,1018],1); -ELEMENTS[5856] = Fluid2D([1018,976,927],1); -ELEMENTS[5857] = Fluid2D([1083,1043,1114],1); -ELEMENTS[5858] = Fluid2D([1114,1043,1087],1); -ELEMENTS[5859] = Fluid2D([1087,1043,1018],1); -ELEMENTS[5860] = Fluid2D([927,976,892],1); -ELEMENTS[5861] = Fluid2D([927,892,833],1); -ELEMENTS[5862] = Fluid2D([715,778,748],1); -ELEMENTS[5863] = Fluid2D([715,748,686],1); -ELEMENTS[5864] = Fluid2D([686,748,722],1); -ELEMENTS[5865] = Fluid2D([715,686,655],1); -ELEMENTS[5866] = Fluid2D([722,748,784],1); -ELEMENTS[5867] = Fluid2D([722,784,756],1); -ELEMENTS[5868] = Fluid2D([756,784,822],1); -ELEMENTS[5869] = Fluid2D([722,756,695],1); -ELEMENTS[5870] = Fluid2D([695,756,731],1); -ELEMENTS[5871] = Fluid2D([731,756,793],1); -ELEMENTS[5872] = Fluid2D([793,756,822],1); -ELEMENTS[5873] = Fluid2D([655,686,629],1); -ELEMENTS[5874] = Fluid2D([655,629,586],1); -ELEMENTS[5875] = Fluid2D([586,629,565],1); -ELEMENTS[5876] = Fluid2D([565,629,604],1); -ELEMENTS[5877] = Fluid2D([604,629,662],1); -ELEMENTS[5878] = Fluid2D([662,629,686],1); -ELEMENTS[5879] = Fluid2D([662,686,722],1); -ELEMENTS[5880] = Fluid2D([662,722,695],1); -ELEMENTS[5881] = Fluid2D([822,784,849],1); -ELEMENTS[5882] = Fluid2D([822,849,887],1); -ELEMENTS[5883] = Fluid2D([662,695,637],1); -ELEMENTS[5884] = Fluid2D([662,637,604],1); -ELEMENTS[5885] = Fluid2D([637,695,668],1); -ELEMENTS[5886] = Fluid2D([637,668,614],1); -ELEMENTS[5887] = Fluid2D([614,668,645],1); -ELEMENTS[5888] = Fluid2D([645,668,706],1); -ELEMENTS[5889] = Fluid2D([706,668,731],1); -ELEMENTS[5890] = Fluid2D([731,668,695],1); -ELEMENTS[5891] = Fluid2D([887,849,919],1); -ELEMENTS[5892] = Fluid2D([887,919,957],1); -ELEMENTS[5893] = Fluid2D([887,957,925],1); -ELEMENTS[5894] = Fluid2D([925,957,995],1); -ELEMENTS[5895] = Fluid2D([995,957,1028],1); -ELEMENTS[5896] = Fluid2D([1028,957,989],1); -ELEMENTS[5897] = Fluid2D([989,957,919],1); -ELEMENTS[5898] = Fluid2D([604,637,581],1); -ELEMENTS[5899] = Fluid2D([604,581,542],1); -ELEMENTS[5900] = Fluid2D([604,542,565],1); -ELEMENTS[5901] = Fluid2D([565,542,497],1); -ELEMENTS[5902] = Fluid2D([542,581,519],1); -ELEMENTS[5903] = Fluid2D([519,581,560],1); -ELEMENTS[5904] = Fluid2D([560,581,614],1); -ELEMENTS[5905] = Fluid2D([519,560,499],1); -ELEMENTS[5906] = Fluid2D([499,560,539],1); -ELEMENTS[5907] = Fluid2D([539,560,592],1); -ELEMENTS[5908] = Fluid2D([614,581,637],1); -ELEMENTS[5909] = Fluid2D([592,560,614],1); -ELEMENTS[5910] = Fluid2D([592,614,645],1); -ELEMENTS[5911] = Fluid2D([592,645,624],1); -ELEMENTS[5912] = Fluid2D([624,645,680],1); -ELEMENTS[5913] = Fluid2D([592,624,564],1); -ELEMENTS[5914] = Fluid2D([564,624,596],1); -ELEMENTS[5915] = Fluid2D([596,624,656],1); -ELEMENTS[5916] = Fluid2D([656,624,680],1); -ELEMENTS[5917] = Fluid2D([596,656,630],1); -ELEMENTS[5918] = Fluid2D([630,656,688],1); -ELEMENTS[5919] = Fluid2D([596,630,575],1); -ELEMENTS[5920] = Fluid2D([575,630,613],1); -ELEMENTS[5921] = Fluid2D([613,630,667],1); -ELEMENTS[5922] = Fluid2D([688,656,714],1); -ELEMENTS[5923] = Fluid2D([714,656,680],1); -ELEMENTS[5924] = Fluid2D([667,630,688],1); -ELEMENTS[5925] = Fluid2D([714,680,740],1); -ELEMENTS[5926] = Fluid2D([714,740,777],1); -ELEMENTS[5927] = Fluid2D([740,680,706],1); -ELEMENTS[5928] = Fluid2D([706,680,645],1); -ELEMENTS[5929] = Fluid2D([777,740,804],1); -ELEMENTS[5930] = Fluid2D([777,804,841],1); -ELEMENTS[5931] = Fluid2D([804,740,766],1); -ELEMENTS[5932] = Fluid2D([766,740,706],1); -ELEMENTS[5933] = Fluid2D([804,766,830],1); -ELEMENTS[5934] = Fluid2D([830,766,793],1); -ELEMENTS[5935] = Fluid2D([793,766,731],1); -ELEMENTS[5936] = Fluid2D([731,766,706],1); -ELEMENTS[5937] = Fluid2D([841,804,868],1); -ELEMENTS[5938] = Fluid2D([841,868,908],1); -ELEMENTS[5939] = Fluid2D([841,908,882],1); -ELEMENTS[5940] = Fluid2D([882,908,952],1); -ELEMENTS[5941] = Fluid2D([908,868,937],1); -ELEMENTS[5942] = Fluid2D([937,868,897],1); -ELEMENTS[5943] = Fluid2D([897,868,830],1); -ELEMENTS[5944] = Fluid2D([952,908,977],1); -ELEMENTS[5945] = Fluid2D([977,908,937],1); -ELEMENTS[5946] = Fluid2D([830,868,804],1); -ELEMENTS[5947] = Fluid2D([977,937,1007],1); -ELEMENTS[5948] = Fluid2D([977,1007,1047],1); -ELEMENTS[5949] = Fluid2D([1007,937,966],1); -ELEMENTS[5950] = Fluid2D([966,937,897],1); -ELEMENTS[5951] = Fluid2D([977,1047,1022],1); -ELEMENTS[5952] = Fluid2D([1022,1047,1092],1); -ELEMENTS[5953] = Fluid2D([1047,1007,1076],1); -ELEMENTS[5954] = Fluid2D([1076,1007,1033],1); -ELEMENTS[5955] = Fluid2D([1033,1007,966],1); -ELEMENTS[5956] = Fluid2D([1033,966,995],1); -ELEMENTS[5957] = Fluid2D([995,966,925],1); -ELEMENTS[5958] = Fluid2D([1092,1047,1117],1); -ELEMENTS[5959] = Fluid2D([1117,1047,1076],1); -ELEMENTS[5960] = Fluid2D([1117,1076,1137],1); -ELEMENTS[5961] = Fluid2D([1137,1076,1103],1); -ELEMENTS[5962] = Fluid2D([1103,1076,1033],1); -ELEMENTS[5963] = Fluid2D([966,897,925],1); -ELEMENTS[5964] = Fluid2D([925,897,857],1); -ELEMENTS[5965] = Fluid2D([925,857,887],1); -ELEMENTS[5966] = Fluid2D([887,857,822],1); -ELEMENTS[5967] = Fluid2D([822,857,793],1); -ELEMENTS[5968] = Fluid2D([793,857,830],1); -ELEMENTS[5969] = Fluid2D([830,857,897],1); -ELEMENTS[5970] = Fluid2D([841,882,816],1); -ELEMENTS[5971] = Fluid2D([841,816,777],1); -ELEMENTS[5972] = Fluid2D([816,882,856],1); -ELEMENTS[5973] = Fluid2D([856,882,922],1); -ELEMENTS[5974] = Fluid2D([777,816,753],1); -ELEMENTS[5975] = Fluid2D([753,816,792],1); -ELEMENTS[5976] = Fluid2D([792,816,856],1); -ELEMENTS[5977] = Fluid2D([856,922,896],1); -ELEMENTS[5978] = Fluid2D([896,922,965],1); -ELEMENTS[5979] = Fluid2D([856,896,831],1); -ELEMENTS[5980] = Fluid2D([831,896,872],1); -ELEMENTS[5981] = Fluid2D([872,896,942],1); -ELEMENTS[5982] = Fluid2D([965,922,993],1); -ELEMENTS[5983] = Fluid2D([993,922,952],1); -ELEMENTS[5984] = Fluid2D([952,922,882],1); -ELEMENTS[5985] = Fluid2D([942,896,965],1); -ELEMENTS[5986] = Fluid2D([942,965,1011],1); -ELEMENTS[5987] = Fluid2D([1011,965,1032],1); -ELEMENTS[5988] = Fluid2D([1032,965,993],1); -ELEMENTS[5989] = Fluid2D([942,1011,985],1); -ELEMENTS[5990] = Fluid2D([985,1011,1055],1); -ELEMENTS[5991] = Fluid2D([942,985,914],1); -ELEMENTS[5992] = Fluid2D([942,914,872],1); -ELEMENTS[5993] = Fluid2D([914,985,959],1); -ELEMENTS[5994] = Fluid2D([914,959,891],1); -ELEMENTS[5995] = Fluid2D([891,959,932],1); -ELEMENTS[5996] = Fluid2D([932,959,1002],1); -ELEMENTS[5997] = Fluid2D([1055,1011,1081],1); -ELEMENTS[5998] = Fluid2D([1081,1011,1032],1); -ELEMENTS[5999] = Fluid2D([872,914,846],1); -ELEMENTS[6000] = Fluid2D([872,846,806],1); -ELEMENTS[6001] = Fluid2D([846,914,891],1); -ELEMENTS[6002] = Fluid2D([846,891,826],1); -ELEMENTS[6003] = Fluid2D([826,891,864],1); -ELEMENTS[6004] = Fluid2D([864,891,932],1); -ELEMENTS[6005] = Fluid2D([864,932,909],1); -ELEMENTS[6006] = Fluid2D([909,932,978],1); -ELEMENTS[6007] = Fluid2D([1002,959,1029],1); -ELEMENTS[6008] = Fluid2D([1029,959,985],1); -ELEMENTS[6009] = Fluid2D([806,846,782],1); -ELEMENTS[6010] = Fluid2D([806,782,744],1); -ELEMENTS[6011] = Fluid2D([782,846,826],1); -ELEMENTS[6012] = Fluid2D([782,826,762],1); -ELEMENTS[6013] = Fluid2D([762,826,800],1); -ELEMENTS[6014] = Fluid2D([800,826,864],1); -ELEMENTS[6015] = Fluid2D([800,864,843],1); -ELEMENTS[6016] = Fluid2D([843,864,909],1); -ELEMENTS[6017] = Fluid2D([843,909,888],1); -ELEMENTS[6018] = Fluid2D([888,909,955],1); -ELEMENTS[6019] = Fluid2D([955,909,978],1); -ELEMENTS[6020] = Fluid2D([955,978,1024],1); -ELEMENTS[6021] = Fluid2D([1024,978,1046],1); -ELEMENTS[6022] = Fluid2D([1046,978,1002],1); -ELEMENTS[6023] = Fluid2D([1002,978,932],1); -ELEMENTS[6024] = Fluid2D([744,782,720],1); -ELEMENTS[6025] = Fluid2D([744,720,683],1); -ELEMENTS[6026] = Fluid2D([720,782,762],1); -ELEMENTS[6027] = Fluid2D([744,683,707],1); -ELEMENTS[6028] = Fluid2D([707,683,646],1); -ELEMENTS[6029] = Fluid2D([744,707,768],1); -ELEMENTS[6030] = Fluid2D([768,707,726],1); -ELEMENTS[6031] = Fluid2D([726,707,667],1); -ELEMENTS[6032] = Fluid2D([646,683,626],1); -ELEMENTS[6033] = Fluid2D([626,683,661],1); -ELEMENTS[6034] = Fluid2D([661,683,720],1); -ELEMENTS[6035] = Fluid2D([661,720,700],1); -ELEMENTS[6036] = Fluid2D([700,720,762],1); -ELEMENTS[6037] = Fluid2D([661,700,643],1); -ELEMENTS[6038] = Fluid2D([661,643,606],1); -ELEMENTS[6039] = Fluid2D([643,700,678],1); -ELEMENTS[6040] = Fluid2D([678,700,737],1); -ELEMENTS[6041] = Fluid2D([606,643,588],1); -ELEMENTS[6042] = Fluid2D([588,643,623],1); -ELEMENTS[6043] = Fluid2D([623,643,678],1); -ELEMENTS[6044] = Fluid2D([623,678,657],1); -ELEMENTS[6045] = Fluid2D([657,678,717],1); -ELEMENTS[6046] = Fluid2D([737,700,762],1); -ELEMENTS[6047] = Fluid2D([667,707,646],1); -ELEMENTS[6048] = Fluid2D([667,646,613],1); -ELEMENTS[6049] = Fluid2D([717,678,737],1); -ELEMENTS[6050] = Fluid2D([717,737,780],1); -ELEMENTS[6051] = Fluid2D([780,737,800],1); -ELEMENTS[6052] = Fluid2D([800,737,762],1); -ELEMENTS[6053] = Fluid2D([613,646,595],1); -ELEMENTS[6054] = Fluid2D([613,595,550],1); -ELEMENTS[6055] = Fluid2D([550,595,528],1); -ELEMENTS[6056] = Fluid2D([528,595,576],1); -ELEMENTS[6057] = Fluid2D([576,595,626],1); -ELEMENTS[6058] = Fluid2D([595,646,626],1); -ELEMENTS[6059] = Fluid2D([576,626,606],1); -ELEMENTS[6060] = Fluid2D([606,626,661],1); -ELEMENTS[6061] = Fluid2D([576,606,554],1); -ELEMENTS[6062] = Fluid2D([576,554,510],1); -ELEMENTS[6063] = Fluid2D([510,554,493],1); -ELEMENTS[6064] = Fluid2D([493,554,531],1); -ELEMENTS[6065] = Fluid2D([531,554,588],1); -ELEMENTS[6066] = Fluid2D([554,606,588],1); -ELEMENTS[6067] = Fluid2D([531,588,572],1); -ELEMENTS[6068] = Fluid2D([572,588,623],1); -ELEMENTS[6069] = Fluid2D([531,572,507],1); -ELEMENTS[6070] = Fluid2D([507,572,547],1); -ELEMENTS[6071] = Fluid2D([547,572,602],1); -ELEMENTS[6072] = Fluid2D([602,572,623],1); -ELEMENTS[6073] = Fluid2D([602,623,657],1); -ELEMENTS[6074] = Fluid2D([547,602,578],1); -ELEMENTS[6075] = Fluid2D([578,602,632],1); -ELEMENTS[6076] = Fluid2D([632,602,657],1); -ELEMENTS[6077] = Fluid2D([632,657,698],1); -ELEMENTS[6078] = Fluid2D([698,657,717],1); -ELEMENTS[6079] = Fluid2D([698,717,760],1); -ELEMENTS[6080] = Fluid2D([760,717,780],1); -ELEMENTS[6081] = Fluid2D([578,632,583],1); -ELEMENTS[6082] = Fluid2D([632,698,679],1); -ELEMENTS[6083] = Fluid2D([679,698,736],1); -ELEMENTS[6084] = Fluid2D([632,679,631],1); -ELEMENTS[6085] = Fluid2D([736,698,760],1); -ELEMENTS[6086] = Fluid2D([736,760,799],1); -ELEMENTS[6087] = Fluid2D([736,799,770],1); -ELEMENTS[6088] = Fluid2D([770,799,844],1); -ELEMENTS[6089] = Fluid2D([799,760,824],1); -ELEMENTS[6090] = Fluid2D([824,760,780],1); -ELEMENTS[6091] = Fluid2D([844,799,862],1); -ELEMENTS[6092] = Fluid2D([844,862,911],1); -ELEMENTS[6093] = Fluid2D([862,799,824],1); -ELEMENTS[6094] = Fluid2D([911,862,930],1); -ELEMENTS[6095] = Fluid2D([930,862,888],1); -ELEMENTS[6096] = Fluid2D([888,862,824],1); -ELEMENTS[6097] = Fluid2D([888,824,843],1); -ELEMENTS[6098] = Fluid2D([843,824,780],1); -ELEMENTS[6099] = Fluid2D([843,780,800],1); -ELEMENTS[6100] = Fluid2D([679,736,699],1); -ELEMENTS[6101] = Fluid2D([753,792,726],1); -ELEMENTS[6102] = Fluid2D([753,726,688],1); -ELEMENTS[6103] = Fluid2D([688,726,667],1); -ELEMENTS[6104] = Fluid2D([726,792,768],1); -ELEMENTS[6105] = Fluid2D([768,792,831],1); -ELEMENTS[6106] = Fluid2D([831,792,856],1); -ELEMENTS[6107] = Fluid2D([768,831,806],1); -ELEMENTS[6108] = Fluid2D([806,831,872],1); -ELEMENTS[6109] = Fluid2D([768,806,744],1); -ELEMENTS[6110] = Fluid2D([753,688,714],1); -ELEMENTS[6111] = Fluid2D([753,714,777],1); -ELEMENTS[6112] = Fluid2D([1114,1087,1148],1); -ELEMENTS[6113] = Fluid2D([1667,1664,1704],1); -ELEMENTS[6114] = Fluid2D([1770,1732,1752],1); -ELEMENTS[6115] = Fluid2D([1752,1732,1716],1); -ELEMENTS[6116] = Fluid2D([1716,1732,1694],1); -ELEMENTS[6117] = Fluid2D([1715,1675,1697],1); -ELEMENTS[6118] = Fluid2D([1620,1635,1595],1); -ELEMENTS[6119] = Fluid2D([1470,1496,1512],1); -ELEMENTS[6120] = Fluid2D([1512,1496,1537],1); -ELEMENTS[6121] = Fluid2D([1512,1537,1554],1); -ELEMENTS[6122] = Fluid2D([1488,1472,1514],1); -ELEMENTS[6123] = Fluid2D([1514,1472,1491],1); -ELEMENTS[6124] = Fluid2D([519,499,457],1); -ELEMENTS[6125] = Fluid2D([1428,1384,1411],1); -ELEMENTS[6126] = Fluid2D([1428,1411,1448],1); -ELEMENTS[6127] = Fluid2D([1411,1384,1335],1); -ELEMENTS[6128] = Fluid2D([1448,1411,1435],1); -ELEMENTS[6129] = Fluid2D([1435,1411,1365],1); -ELEMENTS[6130] = Fluid2D([1448,1435,1491],1); -ELEMENTS[6131] = Fluid2D([1428,1448,1472],1); -ELEMENTS[6132] = Fluid2D([1472,1448,1491],1); -ELEMENTS[6133] = Fluid2D([1535,1576,1558],1); -ELEMENTS[6134] = Fluid2D([1535,1558,1516],1); -ELEMENTS[6135] = Fluid2D([1516,1558,1541],1); -ELEMENTS[6136] = Fluid2D([1535,1516,1494],1); -ELEMENTS[6137] = Fluid2D([1516,1541,1498],1); -ELEMENTS[6138] = Fluid2D([1494,1516,1473],1); -ELEMENTS[6139] = Fluid2D([1535,1494,1513],1); -ELEMENTS[6140] = Fluid2D([1513,1494,1469],1); -ELEMENTS[6141] = Fluid2D([1469,1494,1450],1); -ELEMENTS[6142] = Fluid2D([1450,1494,1473],1); -ELEMENTS[6143] = Fluid2D([1450,1473,1429],1); -ELEMENTS[6144] = Fluid2D([1450,1429,1405],1); -ELEMENTS[6145] = Fluid2D([1429,1473,1455],1); -ELEMENTS[6146] = Fluid2D([1450,1405,1425],1); -ELEMENTS[6147] = Fluid2D([1405,1429,1382],1); -ELEMENTS[6148] = Fluid2D([1455,1473,1498],1); -ELEMENTS[6149] = Fluid2D([1455,1498,1477],1); -ELEMENTS[6150] = Fluid2D([1477,1498,1520],1); -ELEMENTS[6151] = Fluid2D([1516,1498,1473],1); -ELEMENTS[6152] = Fluid2D([1382,1429,1409],1); -ELEMENTS[6153] = Fluid2D([1409,1429,1455],1); -ELEMENTS[6154] = Fluid2D([1520,1498,1541],1); -ELEMENTS[6155] = Fluid2D([1520,1541,1561],1); -ELEMENTS[6156] = Fluid2D([1409,1455,1433],1); -ELEMENTS[6157] = Fluid2D([1433,1455,1477],1); -ELEMENTS[6158] = Fluid2D([1433,1477,1458],1); -ELEMENTS[6159] = Fluid2D([1458,1477,1501],1); -ELEMENTS[6160] = Fluid2D([1501,1477,1520],1); -ELEMENTS[6161] = Fluid2D([1409,1433,1388],1); -ELEMENTS[6162] = Fluid2D([1409,1388,1363],1); -ELEMENTS[6163] = Fluid2D([1363,1388,1340],1); -ELEMENTS[6164] = Fluid2D([1363,1340,1316],1); -ELEMENTS[6165] = Fluid2D([1316,1340,1291],1); -ELEMENTS[6166] = Fluid2D([1291,1340,1319],1); -ELEMENTS[6167] = Fluid2D([1319,1340,1367],1); -ELEMENTS[6168] = Fluid2D([1367,1340,1388],1); -ELEMENTS[6169] = Fluid2D([1367,1388,1413],1); -ELEMENTS[6170] = Fluid2D([1413,1388,1433],1); -ELEMENTS[6171] = Fluid2D([1413,1433,1458],1); -ELEMENTS[6172] = Fluid2D([1413,1458,1438],1); -ELEMENTS[6173] = Fluid2D([1367,1413,1393],1); -ELEMENTS[6174] = Fluid2D([1367,1393,1346],1); -ELEMENTS[6175] = Fluid2D([1393,1413,1438],1); -ELEMENTS[6176] = Fluid2D([1346,1393,1376],1); -ELEMENTS[6177] = Fluid2D([1376,1393,1421],1); -ELEMENTS[6178] = Fluid2D([1421,1393,1438],1); -ELEMENTS[6179] = Fluid2D([1346,1376,1329],1); -ELEMENTS[6180] = Fluid2D([1329,1376,1358],1); -ELEMENTS[6181] = Fluid2D([1358,1376,1404],1); -ELEMENTS[6182] = Fluid2D([1404,1376,1421],1); -ELEMENTS[6183] = Fluid2D([1404,1421,1449],1); -ELEMENTS[6184] = Fluid2D([1404,1449,1431],1); -ELEMENTS[6185] = Fluid2D([1404,1431,1385],1); -ELEMENTS[6186] = Fluid2D([1385,1431,1412],1); -ELEMENTS[6187] = Fluid2D([1358,1404,1385],1); -ELEMENTS[6188] = Fluid2D([1358,1385,1338],1); -ELEMENTS[6189] = Fluid2D([1338,1385,1366],1); -ELEMENTS[6190] = Fluid2D([1366,1385,1412],1); -ELEMENTS[6191] = Fluid2D([1366,1412,1392],1); -ELEMENTS[6192] = Fluid2D([1392,1412,1437],1); -ELEMENTS[6193] = Fluid2D([1366,1392,1345],1); -ELEMENTS[6194] = Fluid2D([1366,1345,1318],1); -ELEMENTS[6195] = Fluid2D([1345,1392,1378],1); -ELEMENTS[6196] = Fluid2D([1378,1392,1423],1); -ELEMENTS[6197] = Fluid2D([1318,1345,1298],1); -ELEMENTS[6198] = Fluid2D([1423,1392,1437],1); -ELEMENTS[6199] = Fluid2D([1298,1345,1331],1); -ELEMENTS[6200] = Fluid2D([1298,1331,1283],1); -ELEMENTS[6201] = Fluid2D([1331,1345,1378],1); -ELEMENTS[6202] = Fluid2D([1283,1331,1315],1); -ELEMENTS[6203] = Fluid2D([1315,1331,1362],1); -ELEMENTS[6204] = Fluid2D([1362,1331,1378],1); -ELEMENTS[6205] = Fluid2D([1362,1378,1407],1); -ELEMENTS[6206] = Fluid2D([1407,1378,1423],1); -ELEMENTS[6207] = Fluid2D([1362,1407,1389],1); -ELEMENTS[6208] = Fluid2D([1362,1389,1343],1); -ELEMENTS[6209] = Fluid2D([1343,1389,1371],1); -ELEMENTS[6210] = Fluid2D([1371,1389,1416],1); -ELEMENTS[6211] = Fluid2D([1389,1407,1434],1); -ELEMENTS[6212] = Fluid2D([1438,1458,1481],1); -ELEMENTS[6213] = Fluid2D([1481,1458,1501],1); -ELEMENTS[6214] = Fluid2D([1434,1407,1452],1); -ELEMENTS[6215] = Fluid2D([1452,1407,1423],1); -ELEMENTS[6216] = Fluid2D([1452,1423,1467],1); -ELEMENTS[6217] = Fluid2D([1467,1423,1437],1); -ELEMENTS[6218] = Fluid2D([1467,1437,1480],1); -ELEMENTS[6219] = Fluid2D([1416,1389,1434],1); -ELEMENTS[6220] = Fluid2D([1425,1405,1379],1); -ELEMENTS[6221] = Fluid2D([1379,1405,1359],1); -ELEMENTS[6222] = Fluid2D([1359,1405,1382],1); -ELEMENTS[6223] = Fluid2D([1379,1359,1332],1); -ELEMENTS[6224] = Fluid2D([1332,1359,1308],1); -ELEMENTS[6225] = Fluid2D([1308,1359,1336],1); -ELEMENTS[6226] = Fluid2D([1336,1359,1382],1); -ELEMENTS[6227] = Fluid2D([1308,1336,1288],1); -ELEMENTS[6228] = Fluid2D([1308,1288,1259],1); -ELEMENTS[6229] = Fluid2D([1288,1336,1316],1); -ELEMENTS[6230] = Fluid2D([1316,1336,1363],1); -ELEMENTS[6231] = Fluid2D([1363,1336,1382],1); -ELEMENTS[6232] = Fluid2D([1259,1288,1236],1); -ELEMENTS[6233] = Fluid2D([1236,1288,1266],1); -ELEMENTS[6234] = Fluid2D([1266,1288,1316],1); -ELEMENTS[6235] = Fluid2D([1266,1316,1291],1); -ELEMENTS[6236] = Fluid2D([1266,1291,1240],1); -ELEMENTS[6237] = Fluid2D([1240,1291,1270],1); -ELEMENTS[6238] = Fluid2D([1270,1291,1319],1); -ELEMENTS[6239] = Fluid2D([1236,1266,1213],1); -ELEMENTS[6240] = Fluid2D([1236,1213,1182],1); -ELEMENTS[6241] = Fluid2D([1182,1213,1159],1); -ELEMENTS[6242] = Fluid2D([1159,1213,1187],1); -ELEMENTS[6243] = Fluid2D([1187,1213,1240],1); -ELEMENTS[6244] = Fluid2D([1240,1213,1266],1); -ELEMENTS[6245] = Fluid2D([1425,1379,1401],1); -ELEMENTS[6246] = Fluid2D([1425,1401,1446],1); -ELEMENTS[6247] = Fluid2D([1425,1446,1469],1); -ELEMENTS[6248] = Fluid2D([1425,1469,1450],1); -ELEMENTS[6249] = Fluid2D([1446,1401,1420],1); -ELEMENTS[6250] = Fluid2D([1420,1401,1375],1); -ELEMENTS[6251] = Fluid2D([1446,1420,1464],1); -ELEMENTS[6252] = Fluid2D([1382,1409,1363],1); -ELEMENTS[6253] = Fluid2D([1319,1367,1346],1); -ELEMENTS[6254] = Fluid2D([1319,1346,1297],1); -ELEMENTS[6255] = Fluid2D([1297,1346,1329],1); -ELEMENTS[6256] = Fluid2D([1297,1329,1281],1); -ELEMENTS[6257] = Fluid2D([1281,1329,1309],1); -ELEMENTS[6258] = Fluid2D([1319,1297,1270],1); -ELEMENTS[6259] = Fluid2D([1281,1309,1260],1); -ELEMENTS[6260] = Fluid2D([1260,1309,1290],1); -ELEMENTS[6261] = Fluid2D([1290,1309,1338],1); -ELEMENTS[6262] = Fluid2D([1338,1309,1358],1); -ELEMENTS[6263] = Fluid2D([1358,1309,1329],1); -ELEMENTS[6264] = Fluid2D([1260,1290,1238],1); -ELEMENTS[6265] = Fluid2D([1260,1238,1206],1); -ELEMENTS[6266] = Fluid2D([1238,1290,1268],1); -ELEMENTS[6267] = Fluid2D([1238,1268,1216],1); -ELEMENTS[6268] = Fluid2D([1216,1268,1249],1); -ELEMENTS[6269] = Fluid2D([1249,1268,1298],1); -ELEMENTS[6270] = Fluid2D([1298,1268,1318],1); -ELEMENTS[6271] = Fluid2D([1318,1268,1290],1); -ELEMENTS[6272] = Fluid2D([1260,1206,1229],1); -ELEMENTS[6273] = Fluid2D([1229,1206,1175],1); -ELEMENTS[6274] = Fluid2D([1260,1229,1281],1); -ELEMENTS[6275] = Fluid2D([1281,1229,1248],1); -ELEMENTS[6276] = Fluid2D([1248,1229,1195],1); -ELEMENTS[6277] = Fluid2D([1175,1206,1151],1); -ELEMENTS[6278] = Fluid2D([1151,1206,1185],1); -ELEMENTS[6279] = Fluid2D([1185,1206,1238],1); -ELEMENTS[6280] = Fluid2D([1185,1238,1216],1); -ELEMENTS[6281] = Fluid2D([1185,1216,1163],1); -ELEMENTS[6282] = Fluid2D([1163,1216,1198],1); -ELEMENTS[6283] = Fluid2D([1198,1216,1249],1); -ELEMENTS[6284] = Fluid2D([1195,1229,1175],1); -ELEMENTS[6285] = Fluid2D([1195,1175,1137],1); -ELEMENTS[6286] = Fluid2D([1270,1297,1248],1); -ELEMENTS[6287] = Fluid2D([1248,1297,1281],1); -ELEMENTS[6288] = Fluid2D([1270,1248,1219],1); -ELEMENTS[6289] = Fluid2D([1270,1219,1240],1); -ELEMENTS[6290] = Fluid2D([1240,1219,1187],1); -ELEMENTS[6291] = Fluid2D([1187,1219,1164],1); -ELEMENTS[6292] = Fluid2D([1164,1219,1195],1); -ELEMENTS[6293] = Fluid2D([1195,1219,1248],1); -ELEMENTS[6294] = Fluid2D([1137,1175,1117],1); -ELEMENTS[6295] = Fluid2D([1117,1175,1151],1); -ELEMENTS[6296] = Fluid2D([1117,1151,1092],1); -ELEMENTS[6297] = Fluid2D([1092,1151,1130],1); -ELEMENTS[6298] = Fluid2D([1092,1130,1063],1); -ELEMENTS[6299] = Fluid2D([1063,1130,1102],1); -ELEMENTS[6300] = Fluid2D([1102,1130,1163],1); -ELEMENTS[6301] = Fluid2D([1092,1063,1022],1); -ELEMENTS[6302] = Fluid2D([1022,1063,993],1); -ELEMENTS[6303] = Fluid2D([993,1063,1032],1); -ELEMENTS[6304] = Fluid2D([1032,1063,1102],1); -ELEMENTS[6305] = Fluid2D([1130,1151,1185],1); -ELEMENTS[6306] = Fluid2D([1163,1130,1185],1); -ELEMENTS[6307] = Fluid2D([1318,1290,1338],1); -ELEMENTS[6308] = Fluid2D([1318,1338,1366],1); -ELEMENTS[6309] = Fluid2D([1163,1198,1141],1); -ELEMENTS[6310] = Fluid2D([1163,1141,1102],1); -ELEMENTS[6311] = Fluid2D([1141,1198,1179],1); -ELEMENTS[6312] = Fluid2D([1179,1198,1232],1); -ELEMENTS[6313] = Fluid2D([1141,1179,1123],1); -ELEMENTS[6314] = Fluid2D([1123,1179,1158],1); -ELEMENTS[6315] = Fluid2D([1123,1158,1099],1); -ELEMENTS[6316] = Fluid2D([1099,1158,1135],1); -ELEMENTS[6317] = Fluid2D([1135,1158,1192],1); -ELEMENTS[6318] = Fluid2D([1179,1232,1212],1); -ELEMENTS[6319] = Fluid2D([1212,1232,1264],1); -ELEMENTS[6320] = Fluid2D([1192,1158,1212],1); -ELEMENTS[6321] = Fluid2D([1212,1158,1179],1); -ELEMENTS[6322] = Fluid2D([1264,1232,1283],1); -ELEMENTS[6323] = Fluid2D([1283,1232,1249],1); -ELEMENTS[6324] = Fluid2D([1283,1249,1298],1); -ELEMENTS[6325] = Fluid2D([1249,1232,1198],1); -ELEMENTS[6326] = Fluid2D([1102,1141,1081],1); -ELEMENTS[6327] = Fluid2D([1102,1081,1032],1); -ELEMENTS[6328] = Fluid2D([1081,1141,1123],1); -ELEMENTS[6329] = Fluid2D([1081,1123,1055],1); -ELEMENTS[6330] = Fluid2D([1055,1123,1099],1); -ELEMENTS[6331] = Fluid2D([1055,1099,1029],1); -ELEMENTS[6332] = Fluid2D([1055,1029,985],1); -ELEMENTS[6333] = Fluid2D([1029,1099,1072],1); -ELEMENTS[6334] = Fluid2D([1029,1072,1002],1); -ELEMENTS[6335] = Fluid2D([1002,1072,1046],1); -ELEMENTS[6336] = Fluid2D([1046,1072,1116],1); -ELEMENTS[6337] = Fluid2D([1116,1072,1135],1); -ELEMENTS[6338] = Fluid2D([1072,1099,1135],1); -ELEMENTS[6339] = Fluid2D([1116,1135,1172],1); -ELEMENTS[6340] = Fluid2D([1116,1172,1155],1); -ELEMENTS[6341] = Fluid2D([1155,1172,1209],1); -ELEMENTS[6342] = Fluid2D([1209,1172,1226],1); -ELEMENTS[6343] = Fluid2D([1226,1172,1192],1); -ELEMENTS[6344] = Fluid2D([1209,1226,1261],1); -ELEMENTS[6345] = Fluid2D([1261,1226,1277],1); -ELEMENTS[6346] = Fluid2D([1277,1226,1245],1); -ELEMENTS[6347] = Fluid2D([1245,1226,1192],1); -ELEMENTS[6348] = Fluid2D([1245,1192,1212],1); -ELEMENTS[6349] = Fluid2D([1172,1135,1192],1); -ELEMENTS[6350] = Fluid2D([1245,1212,1264],1); -ELEMENTS[6351] = Fluid2D([1245,1264,1294],1); -ELEMENTS[6352] = Fluid2D([1245,1294,1277],1); -ELEMENTS[6353] = Fluid2D([1294,1264,1315],1); -ELEMENTS[6354] = Fluid2D([1315,1264,1283],1); -ELEMENTS[6355] = Fluid2D([1294,1315,1343],1); -ELEMENTS[6356] = Fluid2D([1343,1315,1362],1); -ELEMENTS[6357] = Fluid2D([1277,1294,1325],1); -ELEMENTS[6358] = Fluid2D([1325,1294,1343],1); -ELEMENTS[6359] = Fluid2D([1277,1325,1311],1); -ELEMENTS[6360] = Fluid2D([1311,1325,1357],1); -ELEMENTS[6361] = Fluid2D([1357,1325,1371],1); -ELEMENTS[6362] = Fluid2D([1371,1325,1343],1); -ELEMENTS[6363] = Fluid2D([1357,1371,1403],1); -ELEMENTS[6364] = Fluid2D([1357,1403,1386],1); -ELEMENTS[6365] = Fluid2D([1357,1386,1339],1); -ELEMENTS[6366] = Fluid2D([1339,1386,1370],1); -ELEMENTS[6367] = Fluid2D([1357,1339,1311],1); -ELEMENTS[6368] = Fluid2D([1311,1339,1292],1); -ELEMENTS[6369] = Fluid2D([1311,1292,1261],1); -ELEMENTS[6370] = Fluid2D([1261,1292,1241],1); -ELEMENTS[6371] = Fluid2D([1339,1370,1322],1); -ELEMENTS[6372] = Fluid2D([1241,1292,1274],1); -ELEMENTS[6373] = Fluid2D([1322,1370,1356],1); -ELEMENTS[6374] = Fluid2D([1274,1292,1322],1); -ELEMENTS[6375] = Fluid2D([1322,1292,1339],1); -ELEMENTS[6376] = Fluid2D([1322,1356,1310],1); -ELEMENTS[6377] = Fluid2D([1310,1356,1342],1); -ELEMENTS[6378] = Fluid2D([1322,1310,1274],1); -ELEMENTS[6379] = Fluid2D([1274,1310,1262],1); -ELEMENTS[6380] = Fluid2D([1262,1310,1293],1); -ELEMENTS[6381] = Fluid2D([1293,1310,1342],1); -ELEMENTS[6382] = Fluid2D([1293,1342,1327],1); -ELEMENTS[6383] = Fluid2D([1293,1327,1279],1); -ELEMENTS[6384] = Fluid2D([1279,1327,1314],1); -ELEMENTS[6385] = Fluid2D([1293,1279,1242],1); -ELEMENTS[6386] = Fluid2D([1242,1279,1230],1); -ELEMENTS[6387] = Fluid2D([1230,1279,1265],1); -ELEMENTS[6388] = Fluid2D([1265,1279,1314],1); -ELEMENTS[6389] = Fluid2D([1265,1314,1296],1); -ELEMENTS[6390] = Fluid2D([1265,1296,1247],1); -ELEMENTS[6391] = Fluid2D([1247,1296,1287],1); -ELEMENTS[6392] = Fluid2D([1247,1287,1235],1); -ELEMENTS[6393] = Fluid2D([1247,1235,1197],1); -ELEMENTS[6394] = Fluid2D([1197,1235,1181],1); -ELEMENTS[6395] = Fluid2D([1235,1287,1269],1); -ELEMENTS[6396] = Fluid2D([1235,1269,1220],1); -ELEMENTS[6397] = Fluid2D([1220,1269,1258],1); -ELEMENTS[6398] = Fluid2D([1220,1188,1169],1); -ELEMENTS[6399] = Fluid2D([1220,1181,1235],1); -ELEMENTS[6400] = Fluid2D([1403,1371,1416],1); -ELEMENTS[6401] = Fluid2D([1230,1265,1214],1); -ELEMENTS[6402] = Fluid2D([1230,1214,1176],1); -ELEMENTS[6403] = Fluid2D([1214,1265,1247],1); -ELEMENTS[6404] = Fluid2D([1230,1176,1191],1); -ELEMENTS[6405] = Fluid2D([1191,1176,1136],1); -ELEMENTS[6406] = Fluid2D([1136,1176,1120],1); -ELEMENTS[6407] = Fluid2D([1120,1176,1160],1); -ELEMENTS[6408] = Fluid2D([1160,1176,1214],1); -ELEMENTS[6409] = Fluid2D([1160,1214,1197],1); -ELEMENTS[6410] = Fluid2D([1197,1214,1247],1); -ELEMENTS[6411] = Fluid2D([1160,1197,1118],1); -ELEMENTS[6412] = Fluid2D([1191,1136,1156],1); -ELEMENTS[6413] = Fluid2D([1156,1136,1097],1); -ELEMENTS[6414] = Fluid2D([1097,1136,1073],1); -ELEMENTS[6415] = Fluid2D([1073,1136,1120],1); -ELEMENTS[6416] = Fluid2D([1073,1120,1042],1); -ELEMENTS[6417] = Fluid2D([1191,1156,1210],1); -ELEMENTS[6418] = Fluid2D([1191,1210,1242],1); -ELEMENTS[6419] = Fluid2D([1210,1156,1170],1); -ELEMENTS[6420] = Fluid2D([1170,1156,1113],1); -ELEMENTS[6421] = Fluid2D([1113,1156,1097],1); -ELEMENTS[6422] = Fluid2D([1113,1097,1045],1); -ELEMENTS[6423] = Fluid2D([1045,1097,1027],1); -ELEMENTS[6424] = Fluid2D([1027,1097,1073],1); -ELEMENTS[6425] = Fluid2D([1027,1073,1004],1); -ELEMENTS[6426] = Fluid2D([1004,1073,1042],1); -ELEMENTS[6427] = Fluid2D([1113,1045,1069],1); -ELEMENTS[6428] = Fluid2D([1069,1045,999],1); -ELEMENTS[6429] = Fluid2D([1113,1069,1133],1); -ELEMENTS[6430] = Fluid2D([999,1045,980],1); -ELEMENTS[6431] = Fluid2D([980,1045,1027],1); -ELEMENTS[6432] = Fluid2D([980,1027,958],1); -ELEMENTS[6433] = Fluid2D([1133,1069,1096],1); -ELEMENTS[6434] = Fluid2D([1096,1069,1024],1); -ELEMENTS[6435] = Fluid2D([1024,1069,999],1); -ELEMENTS[6436] = Fluid2D([1024,999,955],1); -ELEMENTS[6437] = Fluid2D([955,999,930],1); -ELEMENTS[6438] = Fluid2D([955,930,888],1); -ELEMENTS[6439] = Fluid2D([958,1027,1004],1); -ELEMENTS[6440] = Fluid2D([958,1004,934],1); -ELEMENTS[6441] = Fluid2D([958,934,890],1); -ELEMENTS[6442] = Fluid2D([934,1004,988],1); -ELEMENTS[6443] = Fluid2D([890,934,874],1); -ELEMENTS[6444] = Fluid2D([890,874,812],1); -ELEMENTS[6445] = Fluid2D([874,934,923],1); -ELEMENTS[6446] = Fluid2D([923,934,988],1); -ELEMENTS[6447] = Fluid2D([1242,1210,1262],1); -ELEMENTS[6448] = Fluid2D([1242,1262,1293],1); -ELEMENTS[6449] = Fluid2D([1262,1210,1225],1); -ELEMENTS[6450] = Fluid2D([1262,1225,1274],1); -ELEMENTS[6451] = Fluid2D([1225,1210,1170],1); -ELEMENTS[6452] = Fluid2D([1225,1170,1189],1); -ELEMENTS[6453] = Fluid2D([1189,1170,1133],1); -ELEMENTS[6454] = Fluid2D([1133,1170,1113],1); -ELEMENTS[6455] = Fluid2D([1189,1133,1155],1); -ELEMENTS[6456] = Fluid2D([1155,1133,1096],1); -ELEMENTS[6457] = Fluid2D([1155,1096,1116],1); -ELEMENTS[6458] = Fluid2D([1116,1096,1046],1); -ELEMENTS[6459] = Fluid2D([1046,1096,1024],1); -ELEMENTS[6460] = Fluid2D([1274,1225,1241],1); -ELEMENTS[6461] = Fluid2D([1241,1225,1189],1); -ELEMENTS[6462] = Fluid2D([1241,1189,1209],1); -ELEMENTS[6463] = Fluid2D([1209,1189,1155],1); -ELEMENTS[6464] = Fluid2D([1241,1209,1261],1); -ELEMENTS[6465] = Fluid2D([1277,1311,1261],1); -ELEMENTS[6466] = Fluid2D([1164,1195,1137],1); -ELEMENTS[6467] = Fluid2D([1164,1137,1103],1); -ELEMENTS[6468] = Fluid2D([1164,1103,1131],1); -ELEMENTS[6469] = Fluid2D([1131,1103,1066],1); -ELEMENTS[6470] = Fluid2D([1164,1131,1187],1); -ELEMENTS[6471] = Fluid2D([1066,1103,1033],1); -ELEMENTS[6472] = Fluid2D([1066,1033,995],1); -ELEMENTS[6473] = Fluid2D([1066,995,1028],1); -ELEMENTS[6474] = Fluid2D([1131,1066,1098],1); -ELEMENTS[6475] = Fluid2D([1131,1098,1159],1); -ELEMENTS[6476] = Fluid2D([1131,1159,1187],1); -ELEMENTS[6477] = Fluid2D([1098,1066,1028],1); -ELEMENTS[6478] = Fluid2D([1159,1098,1127],1); -ELEMENTS[6479] = Fluid2D([1159,1127,1182],1); -ELEMENTS[6480] = Fluid2D([1182,1127,1150],1); -ELEMENTS[6481] = Fluid2D([1150,1127,1091],1); -ELEMENTS[6482] = Fluid2D([1182,1150,1205],1); -ELEMENTS[6483] = Fluid2D([1182,1205,1236],1); -ELEMENTS[6484] = Fluid2D([1236,1205,1259],1); -ELEMENTS[6485] = Fluid2D([980,958,911],1); -ELEMENTS[6486] = Fluid2D([911,958,890],1); -ELEMENTS[6487] = Fluid2D([911,890,844],1); -ELEMENTS[6488] = Fluid2D([844,890,812],1); -ELEMENTS[6489] = Fluid2D([980,911,930],1); -ELEMENTS[6490] = Fluid2D([980,930,999],1); -ELEMENTS[6491] = Fluid2D([2978,3001,3003],1); -ELEMENTS[6492] = Fluid2D([993,952,1022],1); -ELEMENTS[6493] = Fluid2D([1022,952,977],1); -ELEMENTS[6494] = Fluid2D([3985,4009,4007],1); -ELEMENTS[6495] = Fluid2D([4028,4009,4034],1); -ELEMENTS[6496] = Fluid2D([566,590,638],1); -ELEMENTS[6497] = Fluid2D([1821,1852,1855],1); -ELEMENTS[6498] = Fluid2D([3794,3760,3789],1); -ELEMENTS[6499] = Fluid2D([3794,3789,3827],1); -ELEMENTS[6500] = Fluid2D([3789,3760,3762],1); -ELEMENTS[6501] = Fluid2D([3789,3762,3791],1); -ELEMENTS[6502] = Fluid2D([3789,3791,3828],1); -ELEMENTS[6503] = Fluid2D([3762,3760,3734],1); -ELEMENTS[6504] = Fluid2D([3762,3734,3737],1); -ELEMENTS[6505] = Fluid2D([3734,3760,3732],1); -ELEMENTS[6506] = Fluid2D([3762,3737,3764],1); -ELEMENTS[6507] = Fluid2D([3762,3764,3791],1); -ELEMENTS[6508] = Fluid2D([3764,3737,3739],1); -ELEMENTS[6509] = Fluid2D([3739,3737,3709],1); -ELEMENTS[6510] = Fluid2D([3739,3709,3712],1); -ELEMENTS[6511] = Fluid2D([3764,3739,3767],1); -ELEMENTS[6512] = Fluid2D([3764,3767,3793],1); -ELEMENTS[6513] = Fluid2D([3767,3739,3752],1); -ELEMENTS[6514] = Fluid2D([3767,3752,3781],1); -ELEMENTS[6515] = Fluid2D([3767,3781,3793],1); -ELEMENTS[6516] = Fluid2D([3737,3734,3707],1); -ELEMENTS[6517] = Fluid2D([3737,3707,3709],1); -ELEMENTS[6518] = Fluid2D([3709,3707,3678],1); -ELEMENTS[6519] = Fluid2D([3678,3707,3676],1); -ELEMENTS[6520] = Fluid2D([3678,3676,3639],1); -ELEMENTS[6521] = Fluid2D([3639,3676,3637],1); -ELEMENTS[6522] = Fluid2D([3639,3637,3614],1); -ELEMENTS[6523] = Fluid2D([3639,3614,3616],1); -ELEMENTS[6524] = Fluid2D([3678,3639,3641],1); -ELEMENTS[6525] = Fluid2D([3616,3614,3593],1); -ELEMENTS[6526] = Fluid2D([3678,3641,3680],1); -ELEMENTS[6527] = Fluid2D([3680,3641,3643],1); -ELEMENTS[6528] = Fluid2D([3712,3709,3680],1); -ELEMENTS[6529] = Fluid2D([3680,3709,3678],1); -ELEMENTS[6530] = Fluid2D([3712,3680,3682],1); -ELEMENTS[6531] = Fluid2D([3712,3682,3714],1); -ELEMENTS[6532] = Fluid2D([3714,3682,3685],1); -ELEMENTS[6533] = Fluid2D([3685,3682,3645],1); -ELEMENTS[6534] = Fluid2D([3645,3682,3643],1); -ELEMENTS[6535] = Fluid2D([3643,3682,3680],1); -ELEMENTS[6536] = Fluid2D([3714,3685,3710],1); -ELEMENTS[6537] = Fluid2D([3710,3685,3687],1); -ELEMENTS[6538] = Fluid2D([3714,3710,3742],1); -ELEMENTS[6539] = Fluid2D([3742,3710,3728],1); -ELEMENTS[6540] = Fluid2D([3728,3710,3687],1); -ELEMENTS[6541] = Fluid2D([3643,3641,3619],1); -ELEMENTS[6542] = Fluid2D([3619,3641,3616],1); -ELEMENTS[6543] = Fluid2D([3616,3641,3639],1); -ELEMENTS[6544] = Fluid2D([3687,3685,3633],1); -ELEMENTS[6545] = Fluid2D([3687,3633,3629],1); -ELEMENTS[6546] = Fluid2D([3633,3685,3645],1); -ELEMENTS[6547] = Fluid2D([3633,3645,3623],1); -ELEMENTS[6548] = Fluid2D([3623,3645,3621],1); -ELEMENTS[6549] = Fluid2D([3623,3621,3599],1); -ELEMENTS[6550] = Fluid2D([3599,3621,3597],1); -ELEMENTS[6551] = Fluid2D([3621,3645,3643],1); -ELEMENTS[6552] = Fluid2D([3621,3643,3619],1); -ELEMENTS[6553] = Fluid2D([3621,3619,3597],1); -ELEMENTS[6554] = Fluid2D([3597,3619,3595],1); -ELEMENTS[6555] = Fluid2D([3595,3619,3616],1); -ELEMENTS[6556] = Fluid2D([3597,3595,3573],1); -ELEMENTS[6557] = Fluid2D([3597,3573,3575],1); -ELEMENTS[6558] = Fluid2D([3575,3573,3551],1); -ELEMENTS[6559] = Fluid2D([3593,3614,3591],1); -ELEMENTS[6560] = Fluid2D([3575,3551,3534],1); -ELEMENTS[6561] = Fluid2D([3573,3595,3571],1); -ELEMENTS[6562] = Fluid2D([3571,3595,3593],1); -ELEMENTS[6563] = Fluid2D([3593,3595,3616],1); -ELEMENTS[6564] = Fluid2D([3742,3728,3756],1); -ELEMENTS[6565] = Fluid2D([3712,3714,3752],1); -ELEMENTS[6566] = Fluid2D([3599,3597,3575],1); -ELEMENTS[6567] = Fluid2D([3599,3575,3558],1); -ELEMENTS[6568] = Fluid2D([3764,3793,3791],1); -ELEMENTS[6569] = Fluid2D([3791,3793,3823],1); -ELEMENTS[6570] = Fluid2D([3623,3599,3582],1); -ELEMENTS[6571] = Fluid2D([3739,3712,3752],1); -ELEMENTS[6572] = Fluid2D([3633,3623,3605],1); -ELEMENTS[6573] = Fluid2D([3882,3897,3863],1); -ELEMENTS[6574] = Fluid2D([1120,1160,1106],1); -ELEMENTS[6575] = Fluid2D([1120,1106,1042],1); -ELEMENTS[6576] = Fluid2D([1106,1160,1118],1); -ELEMENTS[6577] = Fluid2D([2003,2031,2050],1); -ELEMENTS[6578] = Fluid2D([281,293,320],1); -ELEMENTS[6579] = Fluid2D([281,320,308],1); -ELEMENTS[6580] = Fluid2D([308,320,347],1); -ELEMENTS[6581] = Fluid2D([281,308,271],1); -ELEMENTS[6582] = Fluid2D([271,308,295],1); -ELEMENTS[6583] = Fluid2D([271,295,260],1); -ELEMENTS[6584] = Fluid2D([320,293,330],1); -ELEMENTS[6585] = Fluid2D([330,293,306],1); -ELEMENTS[6586] = Fluid2D([330,306,348],1); -ELEMENTS[6587] = Fluid2D([330,348,373],1); -ELEMENTS[6588] = Fluid2D([348,306,321],1); -ELEMENTS[6589] = Fluid2D([308,347,333],1); -ELEMENTS[6590] = Fluid2D([308,333,295],1); -ELEMENTS[6591] = Fluid2D([295,333,322],1); -ELEMENTS[6592] = Fluid2D([295,322,283],1); -ELEMENTS[6593] = Fluid2D([283,322,311],1); -ELEMENTS[6594] = Fluid2D([311,322,349],1); -ELEMENTS[6595] = Fluid2D([349,322,361],1); -ELEMENTS[6596] = Fluid2D([349,361,391],1); -ELEMENTS[6597] = Fluid2D([361,322,333],1); -ELEMENTS[6598] = Fluid2D([391,361,405],1); -ELEMENTS[6599] = Fluid2D([361,333,374],1); -ELEMENTS[6600] = Fluid2D([374,333,347],1); -ELEMENTS[6601] = Fluid2D([260,295,283],1); -ELEMENTS[6602] = Fluid2D([260,283,251],1); -ELEMENTS[6603] = Fluid2D([251,283,273],1); -ELEMENTS[6604] = Fluid2D([273,283,311],1); -ELEMENTS[6605] = Fluid2D([348,321,360],1); -ELEMENTS[6606] = Fluid2D([405,361,374],1); -ELEMENTS[6607] = Fluid2D([360,321,334],1); -ELEMENTS[6608] = Fluid2D([360,334,377],1); -ELEMENTS[6609] = Fluid2D([377,334,350],1); -ELEMENTS[6610] = Fluid2D([377,350,392],1); -ELEMENTS[6611] = Fluid2D([392,350,364],1); -ELEMENTS[6612] = Fluid2D([392,364,409],1); -ELEMENTS[6613] = Fluid2D([409,364,384],1); -ELEMENTS[6614] = Fluid2D([409,384,429],1); -ELEMENTS[6615] = Fluid2D([429,384,400],1); -ELEMENTS[6616] = Fluid2D([374,347,388],1); -ELEMENTS[6617] = Fluid2D([388,347,358],1); -ELEMENTS[6618] = Fluid2D([388,358,402],1); -ELEMENTS[6619] = Fluid2D([402,358,373],1); -ELEMENTS[6620] = Fluid2D([373,358,330],1); -ELEMENTS[6621] = Fluid2D([348,360,389],1); -ELEMENTS[6622] = Fluid2D([389,360,404],1); -ELEMENTS[6623] = Fluid2D([404,360,377],1); -ELEMENTS[6624] = Fluid2D([330,358,320],1); -ELEMENTS[6625] = Fluid2D([320,358,347],1); -ELEMENTS[6626] = Fluid2D([429,400,446],1); -ELEMENTS[6627] = Fluid2D([446,400,417],1); -ELEMENTS[6628] = Fluid2D([429,446,474],1); -ELEMENTS[6629] = Fluid2D([474,446,502],1); -ELEMENTS[6630] = Fluid2D([502,446,475],1); -ELEMENTS[6631] = Fluid2D([475,446,417],1); -ELEMENTS[6632] = Fluid2D([502,475,539],1); -ELEMENTS[6633] = Fluid2D([475,417,437],1); -ELEMENTS[6634] = Fluid2D([475,437,499],1); -ELEMENTS[6635] = Fluid2D([429,474,456],1); -ELEMENTS[6636] = Fluid2D([456,474,512],1); -ELEMENTS[6637] = Fluid2D([429,456,409],1); -ELEMENTS[6638] = Fluid2D([512,474,536],1); -ELEMENTS[6639] = Fluid2D([536,474,502],1); -ELEMENTS[6640] = Fluid2D([536,502,564],1); -ELEMENTS[6641] = Fluid2D([409,456,438],1); -ELEMENTS[6642] = Fluid2D([438,456,485],1); -ELEMENTS[6643] = Fluid2D([485,456,512],1); -ELEMENTS[6644] = Fluid2D([485,512,550],1); -ELEMENTS[6645] = Fluid2D([409,438,392],1); -ELEMENTS[6646] = Fluid2D([392,438,421],1); -ELEMENTS[6647] = Fluid2D([392,421,377],1); -ELEMENTS[6648] = Fluid2D([377,421,404],1); -ELEMENTS[6649] = Fluid2D([404,421,450],1); -ELEMENTS[6650] = Fluid2D([421,438,466],1); -ELEMENTS[6651] = Fluid2D([404,450,434],1); -ELEMENTS[6652] = Fluid2D([434,450,493],1); -ELEMENTS[6653] = Fluid2D([466,438,485],1); -ELEMENTS[6654] = Fluid2D([466,485,528],1); -ELEMENTS[6655] = Fluid2D([450,421,466],1); -ELEMENTS[6656] = Fluid2D([450,466,510],1); -ELEMENTS[6657] = Fluid2D([273,311,301],1); -ELEMENTS[6658] = Fluid2D([301,311,339],1); -ELEMENTS[6659] = Fluid2D([273,301,267],1); -ELEMENTS[6660] = Fluid2D([339,311,349],1); -ELEMENTS[6661] = Fluid2D([339,349,382],1); -ELEMENTS[6662] = Fluid2D([382,349,391],1); -ELEMENTS[6663] = Fluid2D([382,391,424],1); -ELEMENTS[6664] = Fluid2D([424,391,436],1); -ELEMENTS[6665] = Fluid2D([273,267,241],1); -ELEMENTS[6666] = Fluid2D([241,267,237],1); -ELEMENTS[6667] = Fluid2D([436,391,405],1); -ELEMENTS[6668] = Fluid2D([436,405,449],1); -ELEMENTS[6669] = Fluid2D([449,405,418],1); -ELEMENTS[6670] = Fluid2D([449,418,464],1); -ELEMENTS[6671] = Fluid2D([464,418,433],1); -ELEMENTS[6672] = Fluid2D([433,418,388],1); -ELEMENTS[6673] = Fluid2D([388,418,374],1); -ELEMENTS[6674] = Fluid2D([374,418,405],1); -ELEMENTS[6675] = Fluid2D([301,339,327],1); -ELEMENTS[6676] = Fluid2D([327,339,366],1); -ELEMENTS[6677] = Fluid2D([366,339,382],1); -ELEMENTS[6678] = Fluid2D([366,382,410],1); -ELEMENTS[6679] = Fluid2D([410,382,424],1); -ELEMENTS[6680] = Fluid2D([410,424,455],1); -ELEMENTS[6681] = Fluid2D([455,424,468],1); -ELEMENTS[6682] = Fluid2D([468,424,436],1); -ELEMENTS[6683] = Fluid2D([327,366,355],1); -ELEMENTS[6684] = Fluid2D([355,366,399],1); -ELEMENTS[6685] = Fluid2D([327,355,317],1); -ELEMENTS[6686] = Fluid2D([317,355,346],1); -ELEMENTS[6687] = Fluid2D([346,355,387],1); -ELEMENTS[6688] = Fluid2D([399,366,410],1); -ELEMENTS[6689] = Fluid2D([387,355,399],1); -ELEMENTS[6690] = Fluid2D([387,399,430],1); -ELEMENTS[6691] = Fluid2D([430,399,444],1); -ELEMENTS[6692] = Fluid2D([444,399,410],1); -ELEMENTS[6693] = Fluid2D([387,430,419],1); -ELEMENTS[6694] = Fluid2D([419,430,463],1); -ELEMENTS[6695] = Fluid2D([387,419,376],1); -ELEMENTS[6696] = Fluid2D([463,430,476],1); -ELEMENTS[6697] = Fluid2D([376,419,408],1); -ELEMENTS[6698] = Fluid2D([408,419,452],1); -ELEMENTS[6699] = Fluid2D([452,419,463],1); -ELEMENTS[6700] = Fluid2D([452,463,500],1); -ELEMENTS[6701] = Fluid2D([500,463,509],1); -ELEMENTS[6702] = Fluid2D([509,463,476],1); -ELEMENTS[6703] = Fluid2D([476,430,444],1); -ELEMENTS[6704] = Fluid2D([476,444,491],1); -ELEMENTS[6705] = Fluid2D([476,491,524],1); -ELEMENTS[6706] = Fluid2D([524,491,532],1); -ELEMENTS[6707] = Fluid2D([532,491,517],1); -ELEMENTS[6708] = Fluid2D([524,532,563],1); -ELEMENTS[6709] = Fluid2D([491,444,455],1); -ELEMENTS[6710] = Fluid2D([455,444,410],1); -ELEMENTS[6711] = Fluid2D([491,455,517],1); -ELEMENTS[6712] = Fluid2D([237,267,253],1); -ELEMENTS[6713] = Fluid2D([253,267,288],1); -ELEMENTS[6714] = Fluid2D([237,253,225],1); -ELEMENTS[6715] = Fluid2D([288,267,301],1); -ELEMENTS[6716] = Fluid2D([288,301,327],1); -ELEMENTS[6717] = Fluid2D([225,253,247],1); -ELEMENTS[6718] = Fluid2D([225,247,220],1); -ELEMENTS[6719] = Fluid2D([247,253,280],1); -ELEMENTS[6720] = Fluid2D([280,253,288],1); -ELEMENTS[6721] = Fluid2D([280,288,317],1); -ELEMENTS[6722] = Fluid2D([317,288,327],1); -ELEMENTS[6723] = Fluid2D([220,247,240],1); -ELEMENTS[6724] = Fluid2D([220,240,212],1); -ELEMENTS[6725] = Fluid2D([212,240,236],1); -ELEMENTS[6726] = Fluid2D([236,240,265],1); -ELEMENTS[6727] = Fluid2D([236,265,263],1); -ELEMENTS[6728] = Fluid2D([263,265,310],1); -ELEMENTS[6729] = Fluid2D([265,240,272],1); -ELEMENTS[6730] = Fluid2D([272,240,247],1); -ELEMENTS[6731] = Fluid2D([272,247,280],1); -ELEMENTS[6732] = Fluid2D([265,272,297],1); -ELEMENTS[6733] = Fluid2D([297,272,307],1); -ELEMENTS[6734] = Fluid2D([307,272,280],1); -ELEMENTS[6735] = Fluid2D([297,307,335],1); -ELEMENTS[6736] = Fluid2D([335,307,346],1); -ELEMENTS[6737] = Fluid2D([297,335,310],1); -ELEMENTS[6738] = Fluid2D([307,280,317],1); -ELEMENTS[6739] = Fluid2D([307,317,346],1); -ELEMENTS[6740] = Fluid2D([212,236,207],1); -ELEMENTS[6741] = Fluid2D([207,236,227],1); -ELEMENTS[6742] = Fluid2D([227,236,263],1); -ELEMENTS[6743] = Fluid2D([227,263,268],1); -ELEMENTS[6744] = Fluid2D([207,227,200],1); -ELEMENTS[6745] = Fluid2D([200,227,223],1); -ELEMENTS[6746] = Fluid2D([200,223,199],1); -ELEMENTS[6747] = Fluid2D([199,223,217],1); -ELEMENTS[6748] = Fluid2D([223,227,268],1); -ELEMENTS[6749] = Fluid2D([217,223,249],1); -ELEMENTS[6750] = Fluid2D([199,217,195],1); -ELEMENTS[6751] = Fluid2D([195,217,222],1); -ELEMENTS[6752] = Fluid2D([222,217,249],1); -ELEMENTS[6753] = Fluid2D([265,297,310],1); -ELEMENTS[6754] = Fluid2D([433,388,402],1); -ELEMENTS[6755] = Fluid2D([433,402,453],1); -ELEMENTS[6756] = Fluid2D([453,402,416],1); -ELEMENTS[6757] = Fluid2D([433,453,489],1); -ELEMENTS[6758] = Fluid2D([416,402,373],1); -ELEMENTS[6759] = Fluid2D([489,453,507],1); -ELEMENTS[6760] = Fluid2D([433,489,464],1); -ELEMENTS[6761] = Fluid2D([464,489,529],1); -ELEMENTS[6762] = Fluid2D([464,529,496],1); -ELEMENTS[6763] = Fluid2D([529,489,547],1); -ELEMENTS[6764] = Fluid2D([496,529,549],1); -ELEMENTS[6765] = Fluid2D([496,549,551],1); -ELEMENTS[6766] = Fluid2D([453,416,473],1); -ELEMENTS[6767] = Fluid2D([453,473,507],1); -ELEMENTS[6768] = Fluid2D([473,416,434],1); -ELEMENTS[6769] = Fluid2D([549,529,583],1); -ELEMENTS[6770] = Fluid2D([416,373,389],1); -ELEMENTS[6771] = Fluid2D([389,373,348],1); -ELEMENTS[6772] = Fluid2D([473,434,493],1); -ELEMENTS[6773] = Fluid2D([416,389,434],1); -ELEMENTS[6774] = Fluid2D([434,389,404],1); -ELEMENTS[6775] = Fluid2D([468,436,484],1); -ELEMENTS[6776] = Fluid2D([484,436,449],1); -ELEMENTS[6777] = Fluid2D([484,449,496],1); -ELEMENTS[6778] = Fluid2D([496,449,464],1); -ELEMENTS[6779] = Fluid2D([468,484,513],1); -ELEMENTS[6780] = Fluid2D([513,484,551],1); -ELEMENTS[6781] = Fluid2D([468,513,517],1); -ELEMENTS[6782] = Fluid2D([484,496,551],1); -ELEMENTS[6783] = Fluid2D([476,524,509],1); -ELEMENTS[6784] = Fluid2D([509,524,558],1); -ELEMENTS[6785] = Fluid2D([558,524,563],1); -ELEMENTS[6786] = Fluid2D([509,558,545],1); -ELEMENTS[6787] = Fluid2D([545,558,587],1); -ELEMENTS[6788] = Fluid2D([509,545,500],1); -ELEMENTS[6789] = Fluid2D([500,545,544],1); -ELEMENTS[6790] = Fluid2D([587,558,620],1); -ELEMENTS[6791] = Fluid2D([587,620,639],1); -ELEMENTS[6792] = Fluid2D([620,558,563],1); -ELEMENTS[6793] = Fluid2D([545,587,597],1); -ELEMENTS[6794] = Fluid2D([251,273,241],1); -ELEMENTS[6795] = Fluid2D([512,536,575],1); -ELEMENTS[6796] = Fluid2D([452,500,488],1); -ELEMENTS[6797] = Fluid2D([488,500,544],1); -ELEMENTS[6798] = Fluid2D([452,488,443],1); -ELEMENTS[6799] = Fluid2D([452,443,408],1); -ELEMENTS[6800] = Fluid2D([408,443,398],1); -ELEMENTS[6801] = Fluid2D([408,398,365],1); -ELEMENTS[6802] = Fluid2D([398,443,432],1); -ELEMENTS[6803] = Fluid2D([408,365,376],1); -ELEMENTS[6804] = Fluid2D([376,365,335],1); -ELEMENTS[6805] = Fluid2D([398,432,370],1); -ELEMENTS[6806] = Fluid2D([443,488,478],1); -ELEMENTS[6807] = Fluid2D([478,488,522],1); -ELEMENTS[6808] = Fluid2D([443,478,432],1); -ELEMENTS[6809] = Fluid2D([432,478,477],1); -ELEMENTS[6810] = Fluid2D([432,477,413],1); -ELEMENTS[6811] = Fluid2D([522,488,544],1); -ELEMENTS[6812] = Fluid2D([522,544,569],1); -ELEMENTS[6813] = Fluid2D([522,569,523],1); -ELEMENTS[6814] = Fluid2D([522,523,478],1); -ELEMENTS[6815] = Fluid2D([523,569,573],1); -ELEMENTS[6816] = Fluid2D([573,569,618],1); -ELEMENTS[6817] = Fluid2D([523,573,526],1); -ELEMENTS[6818] = Fluid2D([523,526,477],1); -ELEMENTS[6819] = Fluid2D([526,573,567],1); -ELEMENTS[6820] = Fluid2D([526,567,504],1); -ELEMENTS[6821] = Fluid2D([526,504,477],1); -ELEMENTS[6822] = Fluid2D([335,365,310],1); -ELEMENTS[6823] = Fluid2D([477,478,523],1); -ELEMENTS[6824] = Fluid2D([365,398,356],1); -ELEMENTS[6825] = Fluid2D([365,356,310],1); -ELEMENTS[6826] = Fluid2D([356,398,370],1); -ELEMENTS[6827] = Fluid2D([376,335,346],1); -ELEMENTS[6828] = Fluid2D([376,346,387],1); -ELEMENTS[6829] = Fluid2D([455,468,517],1); -ELEMENTS[6830] = Fluid2D([2233,2210,2202],1); -ELEMENTS[6831] = Fluid2D([2233,2202,2228],1); -ELEMENTS[6832] = Fluid2D([2233,2228,2258],1); -ELEMENTS[6833] = Fluid2D([2233,2258,2264],1); -ELEMENTS[6834] = Fluid2D([2258,2228,2251],1); -ELEMENTS[6835] = Fluid2D([2258,2251,2282],1); -ELEMENTS[6836] = Fluid2D([2258,2282,2290],1); -ELEMENTS[6837] = Fluid2D([2258,2290,2264],1); -ELEMENTS[6838] = Fluid2D([2264,2290,2294],1); -ELEMENTS[6839] = Fluid2D([2264,2294,2271],1); -ELEMENTS[6840] = Fluid2D([2271,2294,2301],1); -ELEMENTS[6841] = Fluid2D([2301,2294,2324],1); -ELEMENTS[6842] = Fluid2D([2301,2324,2333],1); -ELEMENTS[6843] = Fluid2D([1980,1939,1971],1); -ELEMENTS[6844] = Fluid2D([3558,3582,3599],1); -ELEMENTS[6845] = Fluid2D([2526,2546,2555],1); -ELEMENTS[6846] = Fluid2D([2555,2546,2576],1); -ELEMENTS[6847] = Fluid2D([2576,2546,2570],1); -ELEMENTS[6848] = Fluid2D([2526,2555,2532],1); -ELEMENTS[6849] = Fluid2D([2570,2546,2542],1); -ELEMENTS[6850] = Fluid2D([2570,2542,2565],1); -ELEMENTS[6851] = Fluid2D([2570,2565,2593],1); -ELEMENTS[6852] = Fluid2D([2593,2565,2586],1); -ELEMENTS[6853] = Fluid2D([2576,2570,2597],1); -ELEMENTS[6854] = Fluid2D([2586,2565,2558],1); -ELEMENTS[6855] = Fluid2D([2597,2570,2593],1); -ELEMENTS[6856] = Fluid2D([2593,2586,2616],1); -ELEMENTS[6857] = Fluid2D([2616,2586,2608],1); -ELEMENTS[6858] = Fluid2D([2526,2532,2502],1); -ELEMENTS[6859] = Fluid2D([2558,2565,2536],1); -ELEMENTS[6860] = Fluid2D([2608,2586,2580],1); -ELEMENTS[6861] = Fluid2D([2616,2608,2636],1); -ELEMENTS[6862] = Fluid2D([2608,2580,2602],1); -ELEMENTS[6863] = Fluid2D([2536,2565,2542],1); -ELEMENTS[6864] = Fluid2D([2536,2542,2513],1); -ELEMENTS[6865] = Fluid2D([2536,2513,2505],1); -ELEMENTS[6866] = Fluid2D([2505,2513,2484],1); -ELEMENTS[6867] = Fluid2D([2505,2484,2476],1); -ELEMENTS[6868] = Fluid2D([2505,2476,2499],1); -ELEMENTS[6869] = Fluid2D([2499,2476,2470],1); -ELEMENTS[6870] = Fluid2D([2636,2608,2631],1); -ELEMENTS[6871] = Fluid2D([2631,2608,2602],1); -ELEMENTS[6872] = Fluid2D([2602,2580,2572],1); -ELEMENTS[6873] = Fluid2D([2572,2580,2550],1); -ELEMENTS[6874] = Fluid2D([2572,2550,2544],1); -ELEMENTS[6875] = Fluid2D([2544,2550,2523],1); -ELEMENTS[6876] = Fluid2D([2523,2550,2529],1); -ELEMENTS[6877] = Fluid2D([2529,2550,2558],1); -ELEMENTS[6878] = Fluid2D([2550,2580,2558],1); -ELEMENTS[6879] = Fluid2D([2558,2580,2586],1); -ELEMENTS[6880] = Fluid2D([2529,2558,2536],1); -ELEMENTS[6881] = Fluid2D([2499,2470,2493],1); -ELEMENTS[6882] = Fluid2D([2499,2493,2523],1); -ELEMENTS[6883] = Fluid2D([2499,2523,2529],1); -ELEMENTS[6884] = Fluid2D([2499,2529,2505],1); -ELEMENTS[6885] = Fluid2D([2505,2529,2536],1); -ELEMENTS[6886] = Fluid2D([2502,2532,2509],1); -ELEMENTS[6887] = Fluid2D([2502,2509,2480],1); -ELEMENTS[6888] = Fluid2D([2509,2532,2539],1); -ELEMENTS[6889] = Fluid2D([2539,2532,2561],1); -ELEMENTS[6890] = Fluid2D([2561,2532,2555],1); -ELEMENTS[6891] = Fluid2D([2509,2539,2517],1); -ELEMENTS[6892] = Fluid2D([2539,2561,2568],1); -ELEMENTS[6893] = Fluid2D([2631,2602,2624],1); -ELEMENTS[6894] = Fluid2D([2572,2544,2567],1); -ELEMENTS[6895] = Fluid2D([2567,2544,2540],1); -ELEMENTS[6896] = Fluid2D([2636,2631,2659],1); -ELEMENTS[6897] = Fluid2D([539,592,564],1); -ELEMENTS[6898] = Fluid2D([539,564,502],1); -ELEMENTS[6899] = Fluid2D([2796,2839,2815],1); -ELEMENTS[6900] = Fluid2D([3305,3324,3328],1); -ELEMENTS[6901] = Fluid2D([3305,3328,3308],1); -ELEMENTS[6902] = Fluid2D([3749,3728,3719],1); -ELEMENTS[6903] = Fluid2D([3719,3728,3687],1); -ELEMENTS[6904] = Fluid2D([3749,3719,3726],1); -ELEMENTS[6905] = Fluid2D([1057,1054,991],1); -ELEMENTS[6906] = Fluid2D([4018,4006,4043],1); -ELEMENTS[6907] = Fluid2D([1950,1932,1917],1); -ELEMENTS[6908] = Fluid2D([1917,1932,1897],1); -ELEMENTS[6909] = Fluid2D([1950,1917,1936],1); -ELEMENTS[6910] = Fluid2D([1897,1932,1913],1); -ELEMENTS[6911] = Fluid2D([1897,1913,1879],1); -ELEMENTS[6912] = Fluid2D([1917,1897,1883],1); -ELEMENTS[6913] = Fluid2D([1883,1897,1865],1); -ELEMENTS[6914] = Fluid2D([1897,1879,1865],1); -ELEMENTS[6915] = Fluid2D([1879,1913,1894],1); -ELEMENTS[6916] = Fluid2D([964,1018,927],1); -ELEMENTS[6917] = Fluid2D([964,927,870],1); -ELEMENTS[6918] = Fluid2D([812,743,770],1); -ELEMENTS[6919] = Fluid2D([1104,1142,1186],1); -ELEMENTS[6920] = Fluid2D([1949,1982,1983],1); -ELEMENTS[6921] = Fluid2D([4222,4201,4189],1); -ELEMENTS[6922] = Fluid2D([1763,1724,1756],1); -ELEMENTS[6923] = Fluid2D([3973,3964,3992],1); -ELEMENTS[6924] = Fluid2D([3973,3992,4015],1); -ELEMENTS[6925] = Fluid2D([1581,1623,1597],1); -ELEMENTS[6926] = Fluid2D([1990,1980,2020],1); -ELEMENTS[6927] = Fluid2D([3368,3392,3399],1); -ELEMENTS[6928] = Fluid2D([3473,3496,3498],1); -ELEMENTS[6929] = Fluid2D([3498,3496,3520],1); -ELEMENTS[6930] = Fluid2D([892,855,796],1); -ELEMENTS[6931] = Fluid2D([2601,2625,2645],1); -ELEMENTS[6932] = Fluid2D([1320,1341,1282],1); -ELEMENTS[6933] = Fluid2D([1320,1282,1271],1); -ELEMENTS[6934] = Fluid2D([3863,3855,3882],1); -ELEMENTS[6935] = Fluid2D([866,834,786],1); -ELEMENTS[6936] = Fluid2D([866,786,820],1); -ELEMENTS[6937] = Fluid2D([820,786,733],1); -ELEMENTS[6938] = Fluid2D([866,820,905],1); -ELEMENTS[6939] = Fluid2D([905,820,855],1); -ELEMENTS[6940] = Fluid2D([855,820,765],1); -ELEMENTS[6941] = Fluid2D([786,834,754],1); -ELEMENTS[6942] = Fluid2D([786,754,702],1); -ELEMENTS[6943] = Fluid2D([754,834,801],1); -ELEMENTS[6944] = Fluid2D([801,834,865],1); -ELEMENTS[6945] = Fluid2D([754,801,724],1); -ELEMENTS[6946] = Fluid2D([754,724,671],1); -ELEMENTS[6947] = Fluid2D([724,801,771],1); -ELEMENTS[6948] = Fluid2D([771,801,836],1); -ELEMENTS[6949] = Fluid2D([801,865,836],1); -ELEMENTS[6950] = Fluid2D([836,865,903],1); -ELEMENTS[6951] = Fluid2D([724,771,692],1); -ELEMENTS[6952] = Fluid2D([724,692,644],1); -ELEMENTS[6953] = Fluid2D([903,865,935],1); -ELEMENTS[6954] = Fluid2D([903,935,972],1); -ELEMENTS[6955] = Fluid2D([972,935,1006],1); -ELEMENTS[6956] = Fluid2D([1101,1095,1034],1); -ELEMENTS[6957] = Fluid2D([1101,1034,1105],1); -ELEMENTS[6958] = Fluid2D([4219,4233,4241],1); -ELEMENTS[6959] = Fluid2D([3118,3093,3115],1); -ELEMENTS[6960] = Fluid2D([3118,3115,3141],1); -ELEMENTS[6961] = Fluid2D([3118,3141,3143],1); -ELEMENTS[6962] = Fluid2D([3141,3115,3138],1); -ELEMENTS[6963] = Fluid2D([3118,3143,3121],1); -ELEMENTS[6964] = Fluid2D([3121,3143,3146],1); -ELEMENTS[6965] = Fluid2D([3121,3146,3123],1); -ELEMENTS[6966] = Fluid2D([3123,3146,3148],1); -ELEMENTS[6967] = Fluid2D([3148,3146,3171],1); -ELEMENTS[6968] = Fluid2D([3148,3171,3174],1); -ELEMENTS[6969] = Fluid2D([3174,3171,3196],1); -ELEMENTS[6970] = Fluid2D([3143,3141,3166],1); -ELEMENTS[6971] = Fluid2D([3123,3148,3128],1); -ELEMENTS[6972] = Fluid2D([3128,3148,3156],1); -ELEMENTS[6973] = Fluid2D([3156,3148,3174],1); -ELEMENTS[6974] = Fluid2D([3123,3128,3101],1); -ELEMENTS[6975] = Fluid2D([3101,3128,3108],1); -ELEMENTS[6976] = Fluid2D([3108,3128,3136],1); -ELEMENTS[6977] = Fluid2D([3136,3128,3156],1); -ELEMENTS[6978] = Fluid2D([3101,3108,3081],1); -ELEMENTS[6979] = Fluid2D([3101,3081,3076],1); -ELEMENTS[6980] = Fluid2D([3076,3081,3053],1); -ELEMENTS[6981] = Fluid2D([3081,3108,3087],1); -ELEMENTS[6982] = Fluid2D([3087,3108,3114],1); -ELEMENTS[6983] = Fluid2D([3114,3108,3136],1); -ELEMENTS[6984] = Fluid2D([3087,3114,3091],1); -ELEMENTS[6985] = Fluid2D([3087,3091,3065],1); -ELEMENTS[6986] = Fluid2D([3065,3091,3069],1); -ELEMENTS[6987] = Fluid2D([796,833,892],1); -ELEMENTS[6988] = Fluid2D([1721,1702,1684],1); -ELEMENTS[6989] = Fluid2D([1721,1684,1708],1); -ELEMENTS[6990] = Fluid2D([1708,1684,1668],1); -ELEMENTS[6991] = Fluid2D([1668,1684,1645],1); -ELEMENTS[6992] = Fluid2D([1708,1668,1696],1); -ELEMENTS[6993] = Fluid2D([1684,1702,1664],1); -ELEMENTS[6994] = Fluid2D([1668,1645,1630],1); -ELEMENTS[6995] = Fluid2D([1696,1668,1658],1); -ELEMENTS[6996] = Fluid2D([1696,1658,1681],1); -ELEMENTS[6997] = Fluid2D([1658,1668,1630],1); -ELEMENTS[6998] = Fluid2D([1645,1684,1664],1); -ELEMENTS[6999] = Fluid2D([3618,3615,3640],1); -ELEMENTS[7000] = Fluid2D([3640,3615,3638],1); -ELEMENTS[7001] = Fluid2D([3618,3640,3642],1); -ELEMENTS[7002] = Fluid2D([3640,3638,3677],1); -ELEMENTS[7003] = Fluid2D([3640,3677,3679],1); -ELEMENTS[7004] = Fluid2D([3677,3638,3675],1); -ELEMENTS[7005] = Fluid2D([3677,3675,3706],1); -ELEMENTS[7006] = Fluid2D([3677,3706,3708],1); -ELEMENTS[7007] = Fluid2D([3640,3679,3642],1); -ELEMENTS[7008] = Fluid2D([3642,3679,3681],1); -ELEMENTS[7009] = Fluid2D([3677,3708,3679],1); -ELEMENTS[7010] = Fluid2D([2207,2230,2227],1); -ELEMENTS[7011] = Fluid2D([1673,1712,1693],1); -ELEMENTS[7012] = Fluid2D([1673,1693,1654],1); -ELEMENTS[7013] = Fluid2D([1654,1693,1677],1); -ELEMENTS[7014] = Fluid2D([1673,1654,1633],1); -ELEMENTS[7015] = Fluid2D([1633,1654,1614],1); -ELEMENTS[7016] = Fluid2D([1614,1654,1636],1); -ELEMENTS[7017] = Fluid2D([1614,1636,1596],1); -ELEMENTS[7018] = Fluid2D([1633,1614,1592],1); -ELEMENTS[7019] = Fluid2D([1633,1592,1612],1); -ELEMENTS[7020] = Fluid2D([1633,1612,1652],1); -ELEMENTS[7021] = Fluid2D([1652,1612,1629],1); -ELEMENTS[7022] = Fluid2D([1652,1629,1671],1); -ELEMENTS[7023] = Fluid2D([1654,1677,1636],1); -ELEMENTS[7024] = Fluid2D([1636,1677,1656],1); -ELEMENTS[7025] = Fluid2D([1636,1656,1616],1); -ELEMENTS[7026] = Fluid2D([1636,1616,1596],1); -ELEMENTS[7027] = Fluid2D([1596,1616,1576],1); -ELEMENTS[7028] = Fluid2D([1673,1633,1652],1); -ELEMENTS[7029] = Fluid2D([232,243,213],1); -ELEMENTS[7030] = Fluid2D([2937,2940,2914],1); -ELEMENTS[7031] = Fluid2D([2937,2914,2911],1); -ELEMENTS[7032] = Fluid2D([2911,2914,2884],1); -ELEMENTS[7033] = Fluid2D([2911,2884,2892],1); -ELEMENTS[7034] = Fluid2D([2884,2914,2889],1); -ELEMENTS[7035] = Fluid2D([2937,2911,2936],1); -ELEMENTS[7036] = Fluid2D([2936,2911,2917],1); -ELEMENTS[7037] = Fluid2D([2884,2889,2863],1); -ELEMENTS[7038] = Fluid2D([2863,2889,2866],1); -ELEMENTS[7039] = Fluid2D([2884,2863,2844],1); -ELEMENTS[7040] = Fluid2D([2863,2866,2839],1); -ELEMENTS[7041] = Fluid2D([2863,2839,2819],1); -ELEMENTS[7042] = Fluid2D([2839,2866,2842],1); -ELEMENTS[7043] = Fluid2D([2839,2842,2815],1); -ELEMENTS[7044] = Fluid2D([2839,2796,2819],1); -ELEMENTS[7045] = Fluid2D([1510,1484,1468],1); -ELEMENTS[7046] = Fluid2D([1510,1468,1497],1); -ELEMENTS[7047] = Fluid2D([1468,1484,1435],1); -ELEMENTS[7048] = Fluid2D([1510,1497,1538],1); -ELEMENTS[7049] = Fluid2D([1497,1468,1454],1); -ELEMENTS[7050] = Fluid2D([1454,1468,1424],1); -ELEMENTS[7051] = Fluid2D([1424,1468,1435],1); -ELEMENTS[7052] = Fluid2D([1497,1454,1479],1); -ELEMENTS[7053] = Fluid2D([3779,3806,3784],1); -ELEMENTS[7054] = Fluid2D([2988,3013,3030],1); -ELEMENTS[7055] = Fluid2D([171,172,185],1); -ELEMENTS[7056] = Fluid2D([185,172,173],1); -ELEMENTS[7057] = Fluid2D([2525,2533,2503],1); -ELEMENTS[7058] = Fluid2D([2525,2503,2495],1); -ELEMENTS[7059] = Fluid2D([2525,2495,2517],1); -ELEMENTS[7060] = Fluid2D([2503,2533,2511],1); -ELEMENTS[7061] = Fluid2D([2495,2503,2473],1); -ELEMENTS[7062] = Fluid2D([3374,3373,3397],1); -ELEMENTS[7063] = Fluid2D([3940,3966,3949],1); -ELEMENTS[7064] = Fluid2D([736,770,699],1); -ELEMENTS[7065] = Fluid2D([2744,2719,2698],1); -ELEMENTS[7066] = Fluid2D([1365,1391,1435],1); -ELEMENTS[7067] = Fluid2D([3864,3865,3896],1); -ELEMENTS[7068] = Fluid2D([610,660,620],1); -ELEMENTS[7069] = Fluid2D([4276,4268,4266],1); -ELEMENTS[7070] = Fluid2D([1831,1820,1862],1); -ELEMENTS[7071] = Fluid2D([3083,3082,3106],1); -ELEMENTS[7072] = Fluid2D([1129,1118,1181],1); -ELEMENTS[7073] = Fluid2D([1129,1181,1169],1); -ELEMENTS[7074] = Fluid2D([1169,1181,1220],1); -ELEMENTS[7075] = Fluid2D([1197,1181,1118],1); -ELEMENTS[7076] = Fluid2D([3201,3225,3199],1); -ELEMENTS[7077] = Fluid2D([3273,3297,3296],1); -ELEMENTS[7078] = Fluid2D([3273,3296,3274],1); -ELEMENTS[7079] = Fluid2D([3296,3297,3327],1); -ELEMENTS[7080] = Fluid2D([3296,3327,3320],1); -ELEMENTS[7081] = Fluid2D([3320,3327,3354],1); -ELEMENTS[7082] = Fluid2D([3327,3297,3321],1); -ELEMENTS[7083] = Fluid2D([3327,3321,3352],1); -ELEMENTS[7084] = Fluid2D([3273,3274,3249],1); -ELEMENTS[7085] = Fluid2D([3688,3686,3717],1); -ELEMENTS[7086] = Fluid2D([3717,3686,3715],1); -ELEMENTS[7087] = Fluid2D([2853,2826,2849],1); -ELEMENTS[7088] = Fluid2D([1052,997,984],1); -ELEMENTS[7089] = Fluid2D([2504,2528,2521],1); -ELEMENTS[7090] = Fluid2D([713,670,654],1); -ELEMENTS[7091] = Fluid2D([654,670,616],1); -ELEMENTS[7092] = Fluid2D([654,616,589],1); -ELEMENTS[7093] = Fluid2D([616,670,628],1); -ELEMENTS[7094] = Fluid2D([628,670,687],1); -ELEMENTS[7095] = Fluid2D([616,628,571],1); -ELEMENTS[7096] = Fluid2D([616,571,543],1); -ELEMENTS[7097] = Fluid2D([543,571,514],1); -ELEMENTS[7098] = Fluid2D([593,571,628],1); -ELEMENTS[7099] = Fluid2D([1842,1806,1829],1); -ELEMENTS[7100] = Fluid2D([1842,1829,1864],1); -ELEMENTS[7101] = Fluid2D([1842,1864,1889],1); -ELEMENTS[7102] = Fluid2D([3759,3757,3787],1); -ELEMENTS[7103] = Fluid2D([3787,3757,3786],1); -ELEMENTS[7104] = Fluid2D([3787,3786,3811],1); -ELEMENTS[7105] = Fluid2D([3811,3786,3812],1); -ELEMENTS[7106] = Fluid2D([3812,3786,3794],1); -ELEMENTS[7107] = Fluid2D([3811,3812,3842],1); -ELEMENTS[7108] = Fluid2D([3842,3812,3827],1); -ELEMENTS[7109] = Fluid2D([3812,3794,3827],1); -ELEMENTS[7110] = Fluid2D([3787,3811,3813],1); -ELEMENTS[7111] = Fluid2D([3813,3811,3840],1); -ELEMENTS[7112] = Fluid2D([3840,3811,3842],1); -ELEMENTS[7113] = Fluid2D([3813,3840,3837],1); -ELEMENTS[7114] = Fluid2D([3813,3837,3814],1); -ELEMENTS[7115] = Fluid2D([3837,3840,3861],1); -ELEMENTS[7116] = Fluid2D([3861,3840,3871],1); -ELEMENTS[7117] = Fluid2D([3861,3871,3901],1); -ELEMENTS[7118] = Fluid2D([3871,3840,3842],1); -ELEMENTS[7119] = Fluid2D([3837,3861,3865],1); -ELEMENTS[7120] = Fluid2D([3865,3861,3893],1); -ELEMENTS[7121] = Fluid2D([3865,3893,3896],1); -ELEMENTS[7122] = Fluid2D([3893,3861,3901],1); -ELEMENTS[7123] = Fluid2D([671,702,754],1); -ELEMENTS[7124] = Fluid2D([3775,3747,3746],1); -ELEMENTS[7125] = Fluid2D([2106,2132,2151],1); -ELEMENTS[7126] = Fluid2D([213,224,191],1); -ELEMENTS[7127] = Fluid2D([3662,3696,3687],1); -ELEMENTS[7128] = Fluid2D([3181,3179,3157],1); -ELEMENTS[7129] = Fluid2D([3157,3179,3153],1); -ELEMENTS[7130] = Fluid2D([1864,1895,1889],1); -ELEMENTS[7131] = Fluid2D([2892,2917,2911],1); -ELEMENTS[7132] = Fluid2D([1114,1145,1083],1); -ELEMENTS[7133] = Fluid2D([3880,3908,3887],1); -ELEMENTS[7134] = Fluid2D([1876,1857,1844],1); -ELEMENTS[7135] = Fluid2D([1239,1271,1282],1); -ELEMENTS[7136] = Fluid2D([547,578,529],1); -ELEMENTS[7137] = Fluid2D([591,598,551],1); -ELEMENTS[7138] = Fluid2D([591,551,549],1); -ELEMENTS[7139] = Fluid2D([4132,4109,4102],1); -ELEMENTS[7140] = Fluid2D([1907,1931,1939],1); -ELEMENTS[7141] = Fluid2D([1939,1931,1971],1); -ELEMENTS[7142] = Fluid2D([3887,3914,3899],1); -ELEMENTS[7143] = Fluid2D([3887,3899,3872],1); -ELEMENTS[7144] = Fluid2D([3872,3899,3871],1); -ELEMENTS[7145] = Fluid2D([3872,3871,3842],1); -ELEMENTS[7146] = Fluid2D([3887,3872,3858],1); -ELEMENTS[7147] = Fluid2D([1868,1860,1893],1); -ELEMENTS[7148] = Fluid2D([1868,1893,1900],1); -ELEMENTS[7149] = Fluid2D([1893,1860,1884],1); -ELEMENTS[7150] = Fluid2D([1884,1860,1850],1); -ELEMENTS[7151] = Fluid2D([1868,1900,1862],1); -ELEMENTS[7152] = Fluid2D([1900,1893,1924],1); -ELEMENTS[7153] = Fluid2D([1900,1924,1934],1); -ELEMENTS[7154] = Fluid2D([1924,1893,1916],1); -ELEMENTS[7155] = Fluid2D([1916,1893,1884],1); -ELEMENTS[7156] = Fluid2D([1924,1916,1949],1); -ELEMENTS[7157] = Fluid2D([1924,1949,1959],1); -ELEMENTS[7158] = Fluid2D([1850,1860,1826],1); -ELEMENTS[7159] = Fluid2D([3464,3488,3503],1); -ELEMENTS[7160] = Fluid2D([3225,3251,3223],1); -ELEMENTS[7161] = Fluid2D([3370,3348,3345],1); -ELEMENTS[7162] = Fluid2D([2698,2722,2744],1); -ELEMENTS[7163] = Fluid2D([3773,3752,3742],1); -ELEMENTS[7164] = Fluid2D([3742,3752,3714],1); -ELEMENTS[7165] = Fluid2D([1070,1068,1001],1); -ELEMENTS[7166] = Fluid2D([1001,1068,1062],1); -ELEMENTS[7167] = Fluid2D([579,530,552],1); -ELEMENTS[7168] = Fluid2D([871,809,874],1); -ELEMENTS[7169] = Fluid2D([3890,3889,3918],1); -ELEMENTS[7170] = Fluid2D([948,987,1036],1); -ELEMENTS[7171] = Fluid2D([2305,2330,2331],1); -ELEMENTS[7172] = Fluid2D([525,567,589],1); -ELEMENTS[7173] = Fluid2D([1218,1207,1165],1); -ELEMENTS[7174] = Fluid2D([1218,1157,1233],1); -ELEMENTS[7175] = Fluid2D([2958,2936,2917],1); -ELEMENTS[7176] = Fluid2D([479,497,542],1); -ELEMENTS[7177] = Fluid2D([1623,1645,1664],1); -ELEMENTS[7178] = Fluid2D([3881,3907,3906],1); -ELEMENTS[7179] = Fluid2D([3906,3907,3932],1); -ELEMENTS[7180] = Fluid2D([3881,3906,3882],1); -ELEMENTS[7181] = Fluid2D([3932,3907,3935],1); -ELEMENTS[7182] = Fluid2D([3932,3967,3952],1); -ELEMENTS[7183] = Fluid2D([3932,3952,3920],1); -ELEMENTS[7184] = Fluid2D([3906,3932,3920],1); -ELEMENTS[7185] = Fluid2D([776,716,763],1); -ELEMENTS[7186] = Fluid2D([3085,3110,3099],1); -ELEMENTS[7187] = Fluid2D([4293,4285,4291],1); -ELEMENTS[7188] = Fluid2D([4293,4291,4297],1); -ELEMENTS[7189] = Fluid2D([4105,4078,4097],1); -ELEMENTS[7190] = Fluid2D([705,763,716],1); -ELEMENTS[7191] = Fluid2D([187,190,206],1); -ELEMENTS[7192] = Fluid2D([206,190,195],1); -ELEMENTS[7193] = Fluid2D([586,565,520],1); -ELEMENTS[7194] = Fluid2D([2455,2479,2501],1); -ELEMENTS[7195] = Fluid2D([1919,1889,1895],1); -ELEMENTS[7196] = Fluid2D([3014,3035,3040],1); -ELEMENTS[7197] = Fluid2D([1152,1143,1093],1); -ELEMENTS[7198] = Fluid2D([4034,4059,4070],1); -ELEMENTS[7199] = Fluid2D([4070,4059,4083],1); -ELEMENTS[7200] = Fluid2D([615,644,692],1); -ELEMENTS[7201] = Fluid2D([1836,1863,1877],1); -ELEMENTS[7202] = Fluid2D([2396,2366,2390],1); -ELEMENTS[7203] = Fluid2D([2056,2080,2100],1); -ELEMENTS[7204] = Fluid2D([3990,3968,3973],1); -ELEMENTS[7205] = Fluid2D([310,289,263],1); -ELEMENTS[7206] = Fluid2D([1886,1848,1875],1); -ELEMENTS[7207] = Fluid2D([596,575,536],1); -ELEMENTS[7208] = Fluid2D([3605,3629,3633],1); -ELEMENTS[7209] = Fluid2D([2844,2867,2884],1); -ELEMENTS[7210] = Fluid2D([4140,4168,4157],1); -ELEMENTS[7211] = Fluid2D([1051,1049,986],1); -ELEMENTS[7212] = Fluid2D([1051,970,1054],1); -ELEMENTS[7213] = Fluid2D([3830,3859,3836],1); -ELEMENTS[7214] = Fluid2D([3836,3859,3868],1); -ELEMENTS[7215] = Fluid2D([510,493,450],1); -ELEMENTS[7216] = Fluid2D([699,631,679],1); -ELEMENTS[7217] = Fluid2D([1177,1211,1246],1); -ELEMENTS[7218] = Fluid2D([3909,3938,3918],1); -ELEMENTS[7219] = Fluid2D([3909,3918,3889],1); -ELEMENTS[7220] = Fluid2D([3909,3889,3884],1); -ELEMENTS[7221] = Fluid2D([3909,3884,3896],1); -ELEMENTS[7222] = Fluid2D([3896,3884,3864],1); -ELEMENTS[7223] = Fluid2D([3864,3884,3866],1); -ELEMENTS[7224] = Fluid2D([3866,3884,3889],1); -ELEMENTS[7225] = Fluid2D([3909,3896,3930],1); -ELEMENTS[7226] = Fluid2D([2604,2629,2632],1); -ELEMENTS[7227] = Fluid2D([2632,2629,2656],1); -ELEMENTS[7228] = Fluid2D([4180,4157,4168],1); -ELEMENTS[7229] = Fluid2D([4180,4168,4201],1); -ELEMENTS[7230] = Fluid2D([1841,1868,1862],1); -ELEMENTS[7231] = Fluid2D([3416,3440,3454],1); -ELEMENTS[7232] = Fluid2D([2001,1971,1958],1); -ELEMENTS[7233] = Fluid2D([2650,2674,2694],1); -ELEMENTS[7234] = Fluid2D([3809,3836,3823],1); -ELEMENTS[7235] = Fluid2D([1086,1000,1026],1); -ELEMENTS[7236] = Fluid2D([1086,1026,1095],1); -ELEMENTS[7237] = Fluid2D([1243,1267,1215],1); -ELEMENTS[7238] = Fluid2D([1161,1084,1122],1); -ELEMENTS[7239] = Fluid2D([1122,1084,1025],1); -ELEMENTS[7240] = Fluid2D([870,907,964],1); -ELEMENTS[7241] = Fluid2D([550,528,485],1); -ELEMENTS[7242] = Fluid2D([1704,1756,1724],1); -ELEMENTS[7243] = Fluid2D([1154,1122,1067],1); -ELEMENTS[7244] = Fluid2D([3531,3554,3555],1); -ELEMENTS[7245] = Fluid2D([3531,3555,3532],1); -ELEMENTS[7246] = Fluid2D([2256,2280,2283],1); -ELEMENTS[7247] = Fluid2D([437,457,499],1); -ELEMENTS[7248] = Fluid2D([3300,3329,3333],1); -ELEMENTS[7249] = Fluid2D([1491,1540,1514],1); -ELEMENTS[7250] = Fluid2D([3832,3856,3855],1); -ELEMENTS[7251] = Fluid2D([3855,3856,3882],1); -ELEMENTS[7252] = Fluid2D([3832,3855,3835],1); -ELEMENTS[7253] = Fluid2D([173,174,186],1); -ELEMENTS[7254] = Fluid2D([186,174,175],1); -ELEMENTS[7255] = Fluid2D([3053,3033,3028],1); -ELEMENTS[7256] = Fluid2D([3037,3061,3078],1); -ELEMENTS[7257] = Fluid2D([3355,3377,3378],1); -ELEMENTS[7258] = Fluid2D([3901,3915,3893],1); -ELEMENTS[7259] = Fluid2D([3893,3915,3921],1); -ELEMENTS[7260] = Fluid2D([3921,3896,3893],1); -ELEMENTS[7261] = Fluid2D([282,249,268],1); -ELEMENTS[7262] = Fluid2D([282,268,303],1); -ELEMENTS[7263] = Fluid2D([282,316,285],1); -ELEMENTS[7264] = Fluid2D([1805,1786,1768],1); -ELEMENTS[7265] = Fluid2D([1810,1831,1848],1); -ELEMENTS[7266] = Fluid2D([1848,1831,1875],1); -ELEMENTS[7267] = Fluid2D([2331,2306,2305],1); -ELEMENTS[7268] = Fluid2D([612,655,586],1); -ELEMENTS[7269] = Fluid2D([612,586,540],1); -ELEMENTS[7270] = Fluid2D([3321,3343,3352],1); -ELEMENTS[7271] = Fluid2D([2552,2577,2573],1); -ELEMENTS[7272] = Fluid2D([2350,2379,2359],1); -ELEMENTS[7273] = Fluid2D([2350,2359,2327],1); -ELEMENTS[7274] = Fluid2D([650,611,593],1); -ELEMENTS[7275] = Fluid2D([1896,1910,1881],1); -ELEMENTS[7276] = Fluid2D([1896,1881,1852],1); -ELEMENTS[7277] = Fluid2D([1115,1105,1058],1); -ELEMENTS[7278] = Fluid2D([1115,1044,1126],1); -ELEMENTS[7279] = Fluid2D([4133,4160,4153],1); -ELEMENTS[7280] = Fluid2D([4133,4136,4110],1); -ELEMENTS[7281] = Fluid2D([733,765,820],1); -ELEMENTS[7282] = Fluid2D([1775,1797,1802],1); -ELEMENTS[7283] = Fluid2D([2157,2182,2198],1); -ELEMENTS[7284] = Fluid2D([1915,1954,1925],1); -ELEMENTS[7285] = Fluid2D([1915,1925,1886],1); -ELEMENTS[7286] = Fluid2D([593,535,571],1); -ELEMENTS[7287] = Fluid2D([514,481,467],1); -ELEMENTS[7288] = Fluid2D([2404,2381,2355],1); -ELEMENTS[7289] = Fluid2D([3726,3753,3768],1); -ELEMENTS[7290] = Fluid2D([2941,2965,2983],1); -ELEMENTS[7291] = Fluid2D([4232,4243,4223],1); -ELEMENTS[7292] = Fluid2D([4232,4223,4218],1); -ELEMENTS[7293] = Fluid2D([4202,4223,4212],1); -ELEMENTS[7294] = Fluid2D([4223,4243,4233],1); -ELEMENTS[7295] = Fluid2D([169,188,180],1); -ELEMENTS[7296] = Fluid2D([169,180,168],1); -ELEMENTS[7297] = Fluid2D([2851,2828,2824],1); -ELEMENTS[7298] = Fluid2D([531,507,473],1); -ELEMENTS[7299] = Fluid2D([1305,1335,1353],1); -ELEMENTS[7300] = Fluid2D([3944,3920,3952],1); -ELEMENTS[7301] = Fluid2D([222,255,235],1); -ELEMENTS[7302] = Fluid2D([1958,1981,2001],1); -ELEMENTS[7303] = Fluid2D([3223,3199,3225],1); -ELEMENTS[7304] = Fluid2D([1968,1996,2006],1); -ELEMENTS[7305] = Fluid2D([3510,3534,3551],1); -ELEMENTS[7306] = Fluid2D([2747,2773,2791],1); -ELEMENTS[7307] = Fluid2D([1466,1444,1422],1); -ELEMENTS[7308] = Fluid2D([3781,3809,3793],1); -ELEMENTS[7309] = Fluid2D([1062,1061,994],1); -ELEMENTS[7310] = Fluid2D([994,1061,1057],1); -ELEMENTS[7311] = Fluid2D([3970,3980,3951],1); -ELEMENTS[7312] = Fluid2D([1025,1067,1122],1); -ELEMENTS[7313] = Fluid2D([739,681,730],1); -ELEMENTS[7314] = Fluid2D([730,681,674],1); -ELEMENTS[7315] = Fluid2D([730,674,718],1); -ELEMENTS[7316] = Fluid2D([718,674,660],1); -ELEMENTS[7317] = Fluid2D([718,660,709],1); -ELEMENTS[7318] = Fluid2D([718,709,769],1); -ELEMENTS[7319] = Fluid2D([730,718,779],1); -ELEMENTS[7320] = Fluid2D([674,681,620],1); -ELEMENTS[7321] = Fluid2D([660,674,620],1); -ELEMENTS[7322] = Fluid2D([718,769,779],1); -ELEMENTS[7323] = Fluid2D([1855,1832,1821],1); -ELEMENTS[7324] = Fluid2D([2355,2380,2404],1); -ELEMENTS[7325] = Fluid2D([504,459,477],1); -ELEMENTS[7326] = Fluid2D([1194,1184,1149],1); -ELEMENTS[7327] = Fluid2D([3935,3958,3967],1); -ELEMENTS[7328] = Fluid2D([1797,1821,1832],1); -ELEMENTS[7329] = Fluid2D([520,540,586],1); -ELEMENTS[7330] = Fluid2D([3133,3157,3153],1); -ELEMENTS[7331] = Fluid2D([3301,3300,3333],1); -ELEMENTS[7332] = Fluid2D([3251,3284,3247],1); -ELEMENTS[7333] = Fluid2D([673,625,618],1); -ELEMENTS[7334] = Fluid2D([618,625,573],1); -ELEMENTS[7335] = Fluid2D([184,187,209],1); -ELEMENTS[7336] = Fluid2D([3529,3506,3505],1); -ELEMENTS[7337] = Fluid2D([2429,2478,2454],1); -ELEMENTS[7338] = Fluid2D([697,654,635],1); -ELEMENTS[7339] = Fluid2D([635,654,589],1); -ELEMENTS[7340] = Fluid2D([697,635,684],1); -ELEMENTS[7341] = Fluid2D([1162,1152,1088],1); -ELEMENTS[7342] = Fluid2D([638,612,566],1); -ELEMENTS[7343] = Fluid2D([2100,2076,2056],1); -ELEMENTS[7344] = Fluid2D([590,615,665],1); -ELEMENTS[7345] = Fluid2D([4015,3990,3973],1); -ELEMENTS[7346] = Fluid2D([2031,2056,2076],1); -ELEMENTS[7347] = Fluid2D([3920,3882,3906],1); -ELEMENTS[7348] = Fluid2D([3582,3605,3623],1); -ELEMENTS[7349] = Fluid2D([1556,1514,1540],1); -ELEMENTS[7350] = Fluid2D([2819,2844,2863],1); -ELEMENTS[7351] = Fluid2D([4233,4212,4223],1); -ELEMENTS[7352] = Fluid2D([576,510,528],1); -ELEMENTS[7353] = Fluid2D([528,510,466],1); -ELEMENTS[7354] = Fluid2D([3989,4018,3993],1); -ELEMENTS[7355] = Fluid2D([1142,1177,1217],1); -ELEMENTS[7356] = Fluid2D([743,699,770],1); -ELEMENTS[7357] = Fluid2D([3943,3973,3942],1); -ELEMENTS[7358] = Fluid2D([1982,1968,2006],1); -ELEMENTS[7359] = Fluid2D([3392,3416,3423],1); -ELEMENTS[7360] = Fluid2D([2625,2650,2645],1); -ELEMENTS[7361] = Fluid2D([670,727,687],1); -ELEMENTS[7362] = Fluid2D([1702,1704,1664],1); -ELEMENTS[7363] = Fluid2D([833,870,927],1); -ELEMENTS[7364] = Fluid2D([2230,2256,2259],1); -ELEMENTS[7365] = Fluid2D([1258,1244,1188],1); -ELEMENTS[7366] = Fluid2D([1484,1491,1435],1); -ELEMENTS[7367] = Fluid2D([1191,1242,1230],1); -ELEMENTS[7368] = Fluid2D([2076,2050,2031],1); -ELEMENTS[7369] = Fluid2D([3806,3832,3835],1); -ELEMENTS[7370] = Fluid2D([3013,3037,3055],1); -ELEMENTS[7371] = Fluid2D([2719,2694,2674],1); -ELEMENTS[7372] = Fluid2D([770,844,812],1); -ELEMENTS[7373] = Fluid2D([1391,1424,1435],1); -ELEMENTS[7374] = Fluid2D([3918,3943,3916],1); -ELEMENTS[7375] = Fluid2D([3823,3828,3791],1); -ELEMENTS[7376] = Fluid2D([2528,2552,2549],1); -ELEMENTS[7377] = Fluid2D([702,733,786],1); -ELEMENTS[7378] = Fluid2D([1756,1775,1802],1); -ELEMENTS[7379] = Fluid2D([2132,2157,2175],1); -ELEMENTS[7380] = Fluid2D([2306,2283,2280],1); -ELEMENTS[7381] = Fluid2D([1895,1886,1925],1); -ELEMENTS[7382] = Fluid2D([3696,3726,3719],1); -ELEMENTS[7383] = Fluid2D([3696,3719,3687],1); -ELEMENTS[7384] = Fluid2D([2917,2941,2958],1); -ELEMENTS[7385] = Fluid2D([3842,3858,3872],1); -ELEMENTS[7386] = Fluid2D([3160,3138,3134],1); -ELEMENTS[7387] = Fluid2D([1271,1305,1320],1); -ELEMENTS[7388] = Fluid2D([613,550,575],1); -ELEMENTS[7389] = Fluid2D([575,550,512],1); -ELEMENTS[7390] = Fluid2D([1931,1958,1971],1); -ELEMENTS[7391] = Fluid2D([3352,3354,3327],1); -ELEMENTS[7392] = Fluid2D([3488,3510,3527],1); -ELEMENTS[7393] = Fluid2D([2722,2747,2768],1); -ELEMENTS[7394] = Fluid2D([809,812,874],1); -ELEMENTS[7395] = Fluid2D([987,1025,1084],1); -ELEMENTS[7396] = Fluid2D([1650,1628,1609],1); -ELEMENTS[7397] = Fluid2D([2330,2355,2381],1); -ELEMENTS[7398] = Fluid2D([1207,1194,1149],1); -ELEMENTS[7399] = Fluid2D([1003,964,907],1); -ELEMENTS[7400] = Fluid2D([459,413,477],1); -ELEMENTS[7401] = Fluid2D([1905,1862,1900],1); -ELEMENTS[7402] = Fluid2D([497,520,565],1); -ELEMENTS[7403] = Fluid2D([3110,3133,3126],1); -ELEMENTS[7404] = Fluid2D([2549,2521,2528],1); -ELEMENTS[7405] = Fluid2D([326,310,356],1); -ELEMENTS[7406] = Fluid2D([326,356,370],1); -ELEMENTS[7407] = Fluid2D([597,544,545],1); -ELEMENTS[7408] = Fluid2D([923,871,874],1); -ELEMENTS[7409] = Fluid2D([4102,4122,4132],1); -ELEMENTS[7410] = Fluid2D([4027,4000,4005],1); -ELEMENTS[7411] = Fluid2D([4005,4000,3977],1); -ELEMENTS[7412] = Fluid2D([1540,1581,1556],1); -ELEMENTS[7413] = Fluid2D([564,596,536],1); -ELEMENTS[7414] = Fluid2D([2479,2504,2521],1); -ELEMENTS[7415] = Fluid2D([1889,1903,1863],1); -ELEMENTS[7416] = Fluid2D([3818,3802,3784],1); -ELEMENTS[7417] = Fluid2D([3818,3784,3806],1); -ELEMENTS[7418] = Fluid2D([3779,3784,3753],1); -ELEMENTS[7419] = Fluid2D([3784,3802,3768],1); -ELEMENTS[7420] = Fluid2D([3269,3247,3284],1); -ELEMENTS[7421] = Fluid2D([1143,1132,1064],1); -ELEMENTS[7422] = Fluid2D([644,671,724],1); -ELEMENTS[7423] = Fluid2D([1863,1842,1889],1); -ELEMENTS[7424] = Fluid2D([2080,2106,2125],1); -ELEMENTS[7425] = Fluid2D([343,325,378],1); -ELEMENTS[7426] = Fluid2D([3629,3662,3687],1); -ELEMENTS[7427] = Fluid2D([3309,3301,3334],1); -ELEMENTS[7428] = Fluid2D([625,684,635],1); -ELEMENTS[7429] = Fluid2D([2867,2892,2884],1); -ELEMENTS[7430] = Fluid2D([493,531,473],1); -ELEMENTS[7431] = Fluid2D([1211,1239,1282],1); -ELEMENTS[7432] = Fluid2D([631,591,583],1); -ELEMENTS[7433] = Fluid2D([631,583,632],1); -ELEMENTS[7434] = Fluid2D([578,583,529],1); -ELEMENTS[7435] = Fluid2D([549,583,591],1); -ELEMENTS[7436] = Fluid2D([4157,4132,4122],1); -ELEMENTS[7437] = Fluid2D([1042,988,1004],1); -ELEMENTS[7438] = Fluid2D([3399,3376,3368],1); -ELEMENTS[7439] = Fluid2D([3440,3464,3479],1); -ELEMENTS[7440] = Fluid2D([2674,2698,2719],1); -ELEMENTS[7441] = Fluid2D([1934,1905,1900],1); -ELEMENTS[7442] = Fluid2D([1079,1070,1016],1); -ELEMENTS[7443] = Fluid2D([289,268,263],1); -ELEMENTS[7444] = Fluid2D([907,948,1003],1); -ELEMENTS[7445] = Fluid2D([2280,2305,2306],1); -ELEMENTS[7446] = Fluid2D([543,589,616],1); -ELEMENTS[7447] = Fluid2D([3329,3320,3356],1); -ELEMENTS[7448] = Fluid2D([457,479,519],1); -ELEMENTS[7449] = Fluid2D([3856,3881,3882],1); -ELEMENTS[7450] = Fluid2D([639,597,587],1); -ELEMENTS[7451] = Fluid2D([639,620,681],1); -ELEMENTS[7452] = Fluid2D([3061,3085,3099],1); -ELEMENTS[7453] = Fluid2D([3899,3901,3871],1); -ELEMENTS[7454] = Fluid2D([3850,3823,3836],1); -ELEMENTS[7455] = Fluid2D([1820,1841,1862],1); -ELEMENTS[7456] = Fluid2D([3343,3368,3376],1); -ELEMENTS[7457] = Fluid2D([2577,2601,2600],1); -ELEMENTS[7458] = Fluid2D([1959,1934,1924],1); -ELEMENTS[7459] = Fluid2D([765,796,855],1); -ELEMENTS[7460] = Fluid2D([1852,1836,1877],1); -ELEMENTS[7461] = Fluid2D([2182,2207,2227],1); -ELEMENTS[7462] = Fluid2D([552,593,611],1); -ELEMENTS[7463] = Fluid2D([2965,2988,3007],1); -ELEMENTS[7464] = Fluid2D([984,1031,1052],1); -ELEMENTS[7465] = Fluid2D([170,171,182],1); -ELEMENTS[7466] = Fluid2D([1335,1365,1411],1); -ELEMENTS[7467] = Fluid2D([507,547,489],1); -ELEMENTS[7468] = Fluid2D([563,610,620],1); -ELEMENTS[7469] = Fluid2D([1981,2003,2024],1); -ELEMENTS[7470] = Fluid2D([4061,4039,4038],1); -ELEMENTS[7471] = Fluid2D([499,539,475],1); -ELEMENTS[7472] = Fluid2D([1996,1990,2028],1); -ELEMENTS[7473] = Fluid2D([3534,3558,3575],1); -ELEMENTS[7474] = Fluid2D([2773,2796,2815],1); -ELEMENTS[7475] = Fluid2D([1067,1104,1154],1); -ELEMENTS[7476] = Fluid2D([2380,2405,2427],1); -ELEMENTS[7477] = Fluid2D([3984,3967,3958],1); -ELEMENTS[7478] = Fluid2D([1184,1173,1109],1); -ELEMENTS[7479] = Fluid2D([540,566,612],1); -ELEMENTS[7480] = Fluid2D([3179,3201,3177],1); -ELEMENTS[7481] = Fluid2D([178,179,198],1); -ELEMENTS[7482] = Fluid2D([542,519,479],1); -ELEMENTS[7483] = Fluid2D([2815,2791,2773],1); -ELEMENTS[7484] = Fluid2D([2020,2028,1990],1); -ELEMENTS[7485] = Fluid2D([3784,3768,3753],1); -ELEMENTS[7486] = Fluid2D([589,567,635],1); -ELEMENTS[7487] = Fluid2D([3835,3818,3806],1); -ELEMENTS[7488] = Fluid2D([3951,3944,3970],1); -ELEMENTS[7489] = Fluid2D([3970,3944,3952],1); -ELEMENTS[7490] = Fluid2D([4212,4188,4202],1); -ELEMENTS[7491] = Fluid2D([3828,3827,3789],1); -ELEMENTS[7492] = Fluid2D([4100,4090,4119],1); -ELEMENTS[7493] = Fluid2D([625,635,567],1); -ELEMENTS[7494] = Fluid2D([4010,4001,4030],1); -ELEMENTS[7495] = Fluid2D([4168,4189,4201],1); -ELEMENTS[7496] = Fluid2D([970,991,1054],1); -ELEMENTS[7497] = Fluid2D([4018,4043,4052],1); -ELEMENTS[7498] = Fluid2D([611,579,552],1); -ELEMENTS[7499] = Fluid2D([687,650,628],1); -ELEMENTS[7500] = Fluid2D([4022,3993,4018],1); -ELEMENTS[7501] = Fluid2D([573,625,567],1); -ELEMENTS[7502] = Fluid2D([4233,4250,4253],1); -ELEMENTS[7503] = Fluid2D([3823,3793,3809],1); -ELEMENTS[7504] = Fluid2D([593,628,650],1); -ELEMENTS[7505] = Fluid2D([222,206,195],1); -ELEMENTS[7506] = Fluid2D([4022,4018,4052],1); -ELEMENTS[7507] = Fluid2D([413,370,432],1); -ELEMENTS[7508] = Fluid2D([268,249,223],1); diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.geo b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.geo deleted file mode 100644 index cf4f8bf2ca79..000000000000 Binary files a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.geo and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.init b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.init deleted file mode 100644 index 4a871f054d43..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.init +++ /dev/null @@ -1,14301 +0,0 @@ -// Fixing degrees of freedom in nodes - -NODES[167](DENSITY,0) = 1000.000000; -NODES[168](DENSITY,0) = 1000.000000; -NODES[169](DENSITY,0) = 1000.000000; -NODES[170](DENSITY,0) = 1000.000000; -NODES[171](DENSITY,0) = 1000.000000; -NODES[172](DENSITY,0) = 1000.000000; -NODES[173](DENSITY,0) = 1000.000000; -NODES[174](DENSITY,0) = 1000.000000; -NODES[175](DENSITY,0) = 1000.000000; -NODES[176](DENSITY,0) = 1000.000000; -NODES[177](DENSITY,0) = 1000.000000; -NODES[178](DENSITY,0) = 1000.000000; -NODES[179](DENSITY,0) = 1000.000000; -NODES[184](DENSITY,0) = 1000.000000; -NODES[187](DENSITY,0) = 1000.000000; -NODES[190](DENSITY,0) = 1000.000000; -NODES[195](DENSITY,0) = 1000.000000; -NODES[199](DENSITY,0) = 1000.000000; -NODES[200](DENSITY,0) = 1000.000000; -NODES[207](DENSITY,0) = 1000.000000; -NODES[212](DENSITY,0) = 1000.000000; -NODES[220](DENSITY,0) = 1000.000000; -NODES[225](DENSITY,0) = 1000.000000; -NODES[237](DENSITY,0) = 1000.000000; -NODES[241](DENSITY,0) = 1000.000000; -NODES[251](DENSITY,0) = 1000.000000; -NODES[260](DENSITY,0) = 1000.000000; -NODES[271](DENSITY,0) = 1000.000000; -NODES[281](DENSITY,0) = 1000.000000; -NODES[293](DENSITY,0) = 1000.000000; -NODES[306](DENSITY,0) = 1000.000000; -NODES[321](DENSITY,0) = 1000.000000; -NODES[334](DENSITY,0) = 1000.000000; -NODES[350](DENSITY,0) = 1000.000000; -NODES[364](DENSITY,0) = 1000.000000; -NODES[384](DENSITY,0) = 1000.000000; -NODES[400](DENSITY,0) = 1000.000000; -NODES[417](DENSITY,0) = 1000.000000; -NODES[437](DENSITY,0) = 1000.000000; -NODES[457](DENSITY,0) = 1000.000000; -NODES[479](DENSITY,0) = 1000.000000; -NODES[497](DENSITY,0) = 1000.000000; -NODES[520](DENSITY,0) = 1000.000000; -NODES[540](DENSITY,0) = 1000.000000; -NODES[566](DENSITY,0) = 1000.000000; -NODES[590](DENSITY,0) = 1000.000000; -NODES[615](DENSITY,0) = 1000.000000; -NODES[644](DENSITY,0) = 1000.000000; -NODES[671](DENSITY,0) = 1000.000000; -NODES[702](DENSITY,0) = 1000.000000; -NODES[733](DENSITY,0) = 1000.000000; -NODES[765](DENSITY,0) = 1000.000000; -NODES[796](DENSITY,0) = 1000.000000; -NODES[833](DENSITY,0) = 1000.000000; -NODES[870](DENSITY,0) = 1000.000000; -NODES[907](DENSITY,0) = 1000.000000; -NODES[948](DENSITY,0) = 1000.000000; -NODES[987](DENSITY,0) = 1000.000000; -NODES[1025](DENSITY,0) = 1000.000000; -NODES[1067](DENSITY,0) = 1000.000000; -NODES[1104](DENSITY,0) = 1000.000000; -NODES[1142](DENSITY,0) = 1000.000000; -NODES[1177](DENSITY,0) = 1000.000000; -NODES[1211](DENSITY,0) = 1000.000000; -NODES[1239](DENSITY,0) = 1000.000000; -NODES[1271](DENSITY,0) = 1000.000000; -NODES[1305](DENSITY,0) = 1000.000000; -NODES[1335](DENSITY,0) = 1000.000000; -NODES[1365](DENSITY,0) = 1000.000000; -NODES[1391](DENSITY,0) = 1000.000000; -NODES[1424](DENSITY,0) = 1000.000000; -NODES[1454](DENSITY,0) = 1000.000000; -NODES[1479](DENSITY,0) = 1000.000000; -NODES[1509](DENSITY,0) = 1000.000000; -NODES[1539](DENSITY,0) = 1000.000000; -NODES[1564](DENSITY,0) = 1000.000000; -NODES[1593](DENSITY,0) = 1000.000000; -NODES[1621](DENSITY,0) = 1000.000000; -NODES[1646](DENSITY,0) = 1000.000000; -NODES[1676](DENSITY,0) = 1000.000000; -NODES[1701](DENSITY,0) = 1000.000000; -NODES[1725](DENSITY,0) = 1000.000000; -NODES[1753](DENSITY,0) = 1000.000000; -NODES[1779](DENSITY,0) = 1000.000000; -NODES[1809](DENSITY,0) = 1000.000000; -NODES[1833](DENSITY,0) = 1000.000000; -NODES[1856](DENSITY,0) = 1000.000000; -NODES[1882](DENSITY,0) = 1000.000000; -NODES[1907](DENSITY,0) = 1000.000000; -NODES[1931](DENSITY,0) = 1000.000000; -NODES[1958](DENSITY,0) = 1000.000000; -NODES[1981](DENSITY,0) = 1000.000000; -NODES[2003](DENSITY,0) = 1000.000000; -NODES[2031](DENSITY,0) = 1000.000000; -NODES[2056](DENSITY,0) = 1000.000000; -NODES[2080](DENSITY,0) = 1000.000000; -NODES[2106](DENSITY,0) = 1000.000000; -NODES[2132](DENSITY,0) = 1000.000000; -NODES[2157](DENSITY,0) = 1000.000000; -NODES[2182](DENSITY,0) = 1000.000000; -NODES[2207](DENSITY,0) = 1000.000000; -NODES[2230](DENSITY,0) = 1000.000000; -NODES[2256](DENSITY,0) = 1000.000000; -NODES[2280](DENSITY,0) = 1000.000000; -NODES[2305](DENSITY,0) = 1000.000000; -NODES[2330](DENSITY,0) = 1000.000000; -NODES[2355](DENSITY,0) = 1000.000000; -NODES[2380](DENSITY,0) = 1000.000000; -NODES[2405](DENSITY,0) = 1000.000000; -NODES[2429](DENSITY,0) = 1000.000000; -NODES[2455](DENSITY,0) = 1000.000000; -NODES[2479](DENSITY,0) = 1000.000000; -NODES[2504](DENSITY,0) = 1000.000000; -NODES[2528](DENSITY,0) = 1000.000000; -NODES[2552](DENSITY,0) = 1000.000000; -NODES[2577](DENSITY,0) = 1000.000000; -NODES[2601](DENSITY,0) = 1000.000000; -NODES[2625](DENSITY,0) = 1000.000000; -NODES[2650](DENSITY,0) = 1000.000000; -NODES[2674](DENSITY,0) = 1000.000000; -NODES[2698](DENSITY,0) = 1000.000000; -NODES[2722](DENSITY,0) = 1000.000000; -NODES[2747](DENSITY,0) = 1000.000000; -NODES[2773](DENSITY,0) = 1000.000000; -NODES[2796](DENSITY,0) = 1000.000000; -NODES[2819](DENSITY,0) = 1000.000000; -NODES[2844](DENSITY,0) = 1000.000000; -NODES[2867](DENSITY,0) = 1000.000000; -NODES[2892](DENSITY,0) = 1000.000000; -NODES[2917](DENSITY,0) = 1000.000000; -NODES[2941](DENSITY,0) = 1000.000000; -NODES[2965](DENSITY,0) = 1000.000000; -NODES[2988](DENSITY,0) = 1000.000000; -NODES[3013](DENSITY,0) = 1000.000000; -NODES[3037](DENSITY,0) = 1000.000000; -NODES[3061](DENSITY,0) = 1000.000000; -NODES[3085](DENSITY,0) = 1000.000000; -NODES[3110](DENSITY,0) = 1000.000000; -NODES[3133](DENSITY,0) = 1000.000000; -NODES[3157](DENSITY,0) = 1000.000000; -NODES[3181](DENSITY,0) = 1000.000000; -NODES[3204](DENSITY,0) = 1000.000000; -NODES[3227](DENSITY,0) = 1000.000000; -NODES[3249](DENSITY,0) = 1000.000000; -NODES[3273](DENSITY,0) = 1000.000000; -NODES[3297](DENSITY,0) = 1000.000000; -NODES[3321](DENSITY,0) = 1000.000000; -NODES[3343](DENSITY,0) = 1000.000000; -NODES[3368](DENSITY,0) = 1000.000000; -NODES[3392](DENSITY,0) = 1000.000000; -NODES[3416](DENSITY,0) = 1000.000000; -NODES[3440](DENSITY,0) = 1000.000000; -NODES[3464](DENSITY,0) = 1000.000000; -NODES[3488](DENSITY,0) = 1000.000000; -NODES[3510](DENSITY,0) = 1000.000000; -NODES[3534](DENSITY,0) = 1000.000000; -NODES[3558](DENSITY,0) = 1000.000000; -NODES[3582](DENSITY,0) = 1000.000000; -NODES[3605](DENSITY,0) = 1000.000000; -NODES[3629](DENSITY,0) = 1000.000000; -NODES[3662](DENSITY,0) = 1000.000000; -NODES[3696](DENSITY,0) = 1000.000000; -NODES[3726](DENSITY,0) = 1000.000000; -NODES[3753](DENSITY,0) = 1000.000000; -NODES[3779](DENSITY,0) = 1000.000000; -NODES[3806](DENSITY,0) = 1000.000000; -NODES[3832](DENSITY,0) = 1000.000000; -NODES[3856](DENSITY,0) = 1000.000000; -NODES[3881](DENSITY,0) = 1000.000000; -NODES[3907](DENSITY,0) = 1000.000000; -NODES[3935](DENSITY,0) = 1000.000000; -NODES[3958](DENSITY,0) = 1000.000000; -NODES[3985](DENSITY,0) = 1000.000000; -NODES[4009](DENSITY,0) = 1000.000000; -NODES[4034](DENSITY,0) = 1000.000000; -NODES[4059](DENSITY,0) = 1000.000000; -NODES[4083](DENSITY,0) = 1000.000000; -NODES[4110](DENSITY,0) = 1000.000000; -NODES[4133](DENSITY,0) = 1000.000000; -NODES[4160](DENSITY,0) = 1000.000000; -NODES[4186](DENSITY,0) = 1000.000000; -NODES[1](IS_STRUCTURE,0) = 1.000000; -NODES[2](IS_STRUCTURE,0) = 1.000000; -NODES[3](IS_STRUCTURE,0) = 1.000000; -NODES[4](IS_STRUCTURE,0) = 1.000000; -NODES[5](IS_STRUCTURE,0) = 1.000000; -NODES[6](IS_STRUCTURE,0) = 1.000000; -NODES[7](IS_STRUCTURE,0) = 1.000000; -NODES[8](IS_STRUCTURE,0) = 1.000000; -NODES[9](IS_STRUCTURE,0) = 1.000000; -NODES[10](IS_STRUCTURE,0) = 1.000000; -NODES[11](IS_STRUCTURE,0) = 1.000000; -NODES[12](IS_STRUCTURE,0) = 1.000000; -NODES[13](IS_STRUCTURE,0) = 1.000000; -NODES[14](IS_STRUCTURE,0) = 1.000000; -NODES[15](IS_STRUCTURE,0) = 1.000000; -NODES[16](IS_STRUCTURE,0) = 1.000000; -NODES[17](IS_STRUCTURE,0) = 1.000000; -NODES[18](IS_STRUCTURE,0) = 1.000000; -NODES[19](IS_STRUCTURE,0) = 1.000000; -NODES[20](IS_STRUCTURE,0) = 1.000000; -NODES[21](IS_STRUCTURE,0) = 1.000000; -NODES[22](IS_STRUCTURE,0) = 1.000000; -NODES[23](IS_STRUCTURE,0) = 1.000000; -NODES[24](IS_STRUCTURE,0) = 1.000000; -NODES[25](IS_STRUCTURE,0) = 1.000000; -NODES[26](IS_STRUCTURE,0) = 1.000000; -NODES[27](IS_STRUCTURE,0) = 1.000000; -NODES[28](IS_STRUCTURE,0) = 1.000000; -NODES[29](IS_STRUCTURE,0) = 1.000000; -NODES[30](IS_STRUCTURE,0) = 1.000000; -NODES[31](IS_STRUCTURE,0) = 1.000000; -NODES[32](IS_STRUCTURE,0) = 1.000000; -NODES[33](IS_STRUCTURE,0) = 1.000000; -NODES[34](IS_STRUCTURE,0) = 1.000000; -NODES[35](IS_STRUCTURE,0) = 1.000000; -NODES[36](IS_STRUCTURE,0) = 1.000000; -NODES[37](IS_STRUCTURE,0) = 1.000000; -NODES[38](IS_STRUCTURE,0) = 1.000000; -NODES[39](IS_STRUCTURE,0) = 1.000000; -NODES[40](IS_STRUCTURE,0) = 1.000000; -NODES[41](IS_STRUCTURE,0) = 1.000000; -NODES[42](IS_STRUCTURE,0) = 1.000000; -NODES[43](IS_STRUCTURE,0) = 1.000000; -NODES[44](IS_STRUCTURE,0) = 1.000000; -NODES[45](IS_STRUCTURE,0) = 1.000000; -NODES[46](IS_STRUCTURE,0) = 1.000000; -NODES[47](IS_STRUCTURE,0) = 1.000000; -NODES[48](IS_STRUCTURE,0) = 1.000000; -NODES[49](IS_STRUCTURE,0) = 1.000000; -NODES[50](IS_STRUCTURE,0) = 1.000000; -NODES[51](IS_STRUCTURE,0) = 1.000000; -NODES[52](IS_STRUCTURE,0) = 1.000000; -NODES[53](IS_STRUCTURE,0) = 1.000000; -NODES[54](IS_STRUCTURE,0) = 1.000000; -NODES[55](IS_STRUCTURE,0) = 1.000000; -NODES[56](IS_STRUCTURE,0) = 1.000000; -NODES[57](IS_STRUCTURE,0) = 1.000000; -NODES[58](IS_STRUCTURE,0) = 1.000000; -NODES[59](IS_STRUCTURE,0) = 1.000000; -NODES[60](IS_STRUCTURE,0) = 1.000000; -NODES[61](IS_STRUCTURE,0) = 1.000000; -NODES[62](IS_STRUCTURE,0) = 1.000000; -NODES[63](IS_STRUCTURE,0) = 1.000000; -NODES[64](IS_STRUCTURE,0) = 1.000000; -NODES[65](IS_STRUCTURE,0) = 1.000000; -NODES[66](IS_STRUCTURE,0) = 1.000000; -NODES[67](IS_STRUCTURE,0) = 1.000000; -NODES[68](IS_STRUCTURE,0) = 1.000000; -NODES[69](IS_STRUCTURE,0) = 1.000000; -NODES[70](IS_STRUCTURE,0) = 1.000000; -NODES[71](IS_STRUCTURE,0) = 1.000000; -NODES[72](IS_STRUCTURE,0) = 1.000000; -NODES[73](IS_STRUCTURE,0) = 1.000000; -NODES[74](IS_STRUCTURE,0) = 1.000000; -NODES[75](IS_STRUCTURE,0) = 1.000000; -NODES[76](IS_STRUCTURE,0) = 1.000000; -NODES[77](IS_STRUCTURE,0) = 1.000000; -NODES[78](IS_STRUCTURE,0) = 1.000000; -NODES[79](IS_STRUCTURE,0) = 1.000000; -NODES[80](IS_STRUCTURE,0) = 1.000000; -NODES[81](IS_STRUCTURE,0) = 1.000000; -NODES[82](IS_STRUCTURE,0) = 1.000000; -NODES[83](IS_STRUCTURE,0) = 1.000000; -NODES[84](IS_STRUCTURE,0) = 1.000000; -NODES[85](IS_STRUCTURE,0) = 1.000000; -NODES[86](IS_STRUCTURE,0) = 1.000000; -NODES[87](IS_STRUCTURE,0) = 1.000000; -NODES[88](IS_STRUCTURE,0) = 1.000000; -NODES[89](IS_STRUCTURE,0) = 1.000000; -NODES[90](IS_STRUCTURE,0) = 1.000000; -NODES[91](IS_STRUCTURE,0) = 1.000000; -NODES[92](IS_STRUCTURE,0) = 1.000000; -NODES[93](IS_STRUCTURE,0) = 1.000000; -NODES[94](IS_STRUCTURE,0) = 1.000000; -NODES[95](IS_STRUCTURE,0) = 1.000000; -NODES[96](IS_STRUCTURE,0) = 1.000000; -NODES[97](IS_STRUCTURE,0) = 1.000000; -NODES[98](IS_STRUCTURE,0) = 1.000000; -NODES[99](IS_STRUCTURE,0) = 1.000000; -NODES[100](IS_STRUCTURE,0) = 1.000000; -NODES[101](IS_STRUCTURE,0) = 1.000000; -NODES[102](IS_STRUCTURE,0) = 1.000000; -NODES[103](IS_STRUCTURE,0) = 1.000000; -NODES[104](IS_STRUCTURE,0) = 1.000000; -NODES[105](IS_STRUCTURE,0) = 1.000000; -NODES[106](IS_STRUCTURE,0) = 1.000000; -NODES[107](IS_STRUCTURE,0) = 1.000000; -NODES[108](IS_STRUCTURE,0) = 1.000000; -NODES[109](IS_STRUCTURE,0) = 1.000000; -NODES[110](IS_STRUCTURE,0) = 1.000000; -NODES[111](IS_STRUCTURE,0) = 1.000000; -NODES[112](IS_STRUCTURE,0) = 1.000000; -NODES[113](IS_STRUCTURE,0) = 1.000000; -NODES[114](IS_STRUCTURE,0) = 1.000000; -NODES[115](IS_STRUCTURE,0) = 1.000000; -NODES[116](IS_STRUCTURE,0) = 1.000000; -NODES[117](IS_STRUCTURE,0) = 1.000000; -NODES[118](IS_STRUCTURE,0) = 1.000000; -NODES[119](IS_STRUCTURE,0) = 1.000000; -NODES[120](IS_STRUCTURE,0) = 1.000000; -NODES[121](IS_STRUCTURE,0) = 1.000000; -NODES[122](IS_STRUCTURE,0) = 1.000000; -NODES[123](IS_STRUCTURE,0) = 1.000000; -NODES[124](IS_STRUCTURE,0) = 1.000000; -NODES[125](IS_STRUCTURE,0) = 1.000000; -NODES[126](IS_STRUCTURE,0) = 1.000000; -NODES[127](IS_STRUCTURE,0) = 1.000000; -NODES[128](IS_STRUCTURE,0) = 1.000000; -NODES[129](IS_STRUCTURE,0) = 1.000000; -NODES[130](IS_STRUCTURE,0) = 1.000000; -NODES[131](IS_STRUCTURE,0) = 1.000000; -NODES[132](IS_STRUCTURE,0) = 1.000000; -NODES[133](IS_STRUCTURE,0) = 1.000000; -NODES[134](IS_STRUCTURE,0) = 1.000000; -NODES[135](IS_STRUCTURE,0) = 1.000000; -NODES[136](IS_STRUCTURE,0) = 1.000000; -NODES[137](IS_STRUCTURE,0) = 1.000000; -NODES[138](IS_STRUCTURE,0) = 1.000000; -NODES[139](IS_STRUCTURE,0) = 1.000000; -NODES[140](IS_STRUCTURE,0) = 1.000000; -NODES[141](IS_STRUCTURE,0) = 1.000000; -NODES[142](IS_STRUCTURE,0) = 1.000000; -NODES[143](IS_STRUCTURE,0) = 1.000000; -NODES[144](IS_STRUCTURE,0) = 1.000000; -NODES[145](IS_STRUCTURE,0) = 1.000000; -NODES[146](IS_STRUCTURE,0) = 1.000000; -NODES[147](IS_STRUCTURE,0) = 1.000000; -NODES[148](IS_STRUCTURE,0) = 1.000000; -NODES[149](IS_STRUCTURE,0) = 1.000000; -NODES[150](IS_STRUCTURE,0) = 1.000000; -NODES[151](IS_STRUCTURE,0) = 1.000000; -NODES[152](IS_STRUCTURE,0) = 1.000000; -NODES[153](IS_STRUCTURE,0) = 1.000000; -NODES[154](IS_STRUCTURE,0) = 1.000000; -NODES[155](IS_STRUCTURE,0) = 1.000000; -NODES[156](IS_STRUCTURE,0) = 1.000000; -NODES[157](IS_STRUCTURE,0) = 1.000000; -NODES[158](IS_STRUCTURE,0) = 1.000000; -NODES[159](IS_STRUCTURE,0) = 1.000000; -NODES[160](IS_STRUCTURE,0) = 1.000000; -NODES[161](IS_STRUCTURE,0) = 1.000000; -NODES[162](IS_STRUCTURE,0) = 1.000000; -NODES[163](IS_STRUCTURE,0) = 1.000000; -NODES[164](IS_STRUCTURE,0) = 1.000000; -NODES[165](IS_STRUCTURE,0) = 1.000000; -NODES[166](IS_STRUCTURE,0) = 1.000000; -NODES[167](IS_STRUCTURE,0) = 1.000000; -NODES[181](IS_STRUCTURE,0) = 1.000000; -NODES[183](IS_STRUCTURE,0) = 1.000000; -NODES[202](IS_STRUCTURE,0) = 1.000000; -NODES[204](IS_STRUCTURE,0) = 1.000000; -NODES[228](IS_STRUCTURE,0) = 1.000000; -NODES[231](IS_STRUCTURE,0) = 1.000000; -NODES[257](IS_STRUCTURE,0) = 1.000000; -NODES[261](IS_STRUCTURE,0) = 1.000000; -NODES[291](IS_STRUCTURE,0) = 1.000000; -NODES[299](IS_STRUCTURE,0) = 1.000000; -NODES[329](IS_STRUCTURE,0) = 1.000000; -NODES[337](IS_STRUCTURE,0) = 1.000000; -NODES[371](IS_STRUCTURE,0) = 1.000000; -NODES[381](IS_STRUCTURE,0) = 1.000000; -NODES[414](IS_STRUCTURE,0) = 1.000000; -NODES[425](IS_STRUCTURE,0) = 1.000000; -NODES[462](IS_STRUCTURE,0) = 1.000000; -NODES[470](IS_STRUCTURE,0) = 1.000000; -NODES[505](IS_STRUCTURE,0) = 1.000000; -NODES[518](IS_STRUCTURE,0) = 1.000000; -NODES[557](IS_STRUCTURE,0) = 1.000000; -NODES[570](IS_STRUCTURE,0) = 1.000000; -NODES[607](IS_STRUCTURE,0) = 1.000000; -NODES[622](IS_STRUCTURE,0) = 1.000000; -NODES[663](IS_STRUCTURE,0) = 1.000000; -NODES[677](IS_STRUCTURE,0) = 1.000000; -NODES[721](IS_STRUCTURE,0) = 1.000000; -NODES[738](IS_STRUCTURE,0) = 1.000000; -NODES[781](IS_STRUCTURE,0) = 1.000000; -NODES[802](IS_STRUCTURE,0) = 1.000000; -NODES[845](IS_STRUCTURE,0) = 1.000000; -NODES[867](IS_STRUCTURE,0) = 1.000000; -NODES[912](IS_STRUCTURE,0) = 1.000000; -NODES[938](IS_STRUCTURE,0) = 1.000000; -NODES[983](IS_STRUCTURE,0) = 1.000000; -NODES[1009](IS_STRUCTURE,0) = 1.000000; -NODES[1048](IS_STRUCTURE,0) = 1.000000; -NODES[1049](IS_STRUCTURE,0) = 1.000000; -NODES[1051](IS_STRUCTURE,0) = 1.000000; -NODES[1054](IS_STRUCTURE,0) = 1.000000; -NODES[1057](IS_STRUCTURE,0) = 1.000000; -NODES[1061](IS_STRUCTURE,0) = 1.000000; -NODES[1062](IS_STRUCTURE,0) = 1.000000; -NODES[1068](IS_STRUCTURE,0) = 1.000000; -NODES[1070](IS_STRUCTURE,0) = 1.000000; -NODES[1079](IS_STRUCTURE,0) = 1.000000; -NODES[1080](IS_STRUCTURE,0) = 1.000000; -NODES[1086](IS_STRUCTURE,0) = 1.000000; -NODES[1095](IS_STRUCTURE,0) = 1.000000; -NODES[1101](IS_STRUCTURE,0) = 1.000000; -NODES[1105](IS_STRUCTURE,0) = 1.000000; -NODES[1115](IS_STRUCTURE,0) = 1.000000; -NODES[1126](IS_STRUCTURE,0) = 1.000000; -NODES[1132](IS_STRUCTURE,0) = 1.000000; -NODES[1140](IS_STRUCTURE,0) = 1.000000; -NODES[1143](IS_STRUCTURE,0) = 1.000000; -NODES[1152](IS_STRUCTURE,0) = 1.000000; -NODES[1162](IS_STRUCTURE,0) = 1.000000; -NODES[1173](IS_STRUCTURE,0) = 1.000000; -NODES[1184](IS_STRUCTURE,0) = 1.000000; -NODES[1194](IS_STRUCTURE,0) = 1.000000; -NODES[1200](IS_STRUCTURE,0) = 1.000000; -NODES[1207](IS_STRUCTURE,0) = 1.000000; -NODES[1218](IS_STRUCTURE,0) = 1.000000; -NODES[1233](IS_STRUCTURE,0) = 1.000000; -NODES[1244](IS_STRUCTURE,0) = 1.000000; -NODES[1252](IS_STRUCTURE,0) = 1.000000; -NODES[1258](IS_STRUCTURE,0) = 1.000000; -NODES[1269](IS_STRUCTURE,0) = 1.000000; -NODES[1287](IS_STRUCTURE,0) = 1.000000; -NODES[1296](IS_STRUCTURE,0) = 1.000000; -NODES[1301](IS_STRUCTURE,0) = 1.000000; -NODES[1314](IS_STRUCTURE,0) = 1.000000; -NODES[1327](IS_STRUCTURE,0) = 1.000000; -NODES[1342](IS_STRUCTURE,0) = 1.000000; -NODES[1349](IS_STRUCTURE,0) = 1.000000; -NODES[1356](IS_STRUCTURE,0) = 1.000000; -NODES[1370](IS_STRUCTURE,0) = 1.000000; -NODES[1386](IS_STRUCTURE,0) = 1.000000; -NODES[1396](IS_STRUCTURE,0) = 1.000000; -NODES[1403](IS_STRUCTURE,0) = 1.000000; -NODES[1416](IS_STRUCTURE,0) = 1.000000; -NODES[1434](IS_STRUCTURE,0) = 1.000000; -NODES[1441](IS_STRUCTURE,0) = 1.000000; -NODES[1452](IS_STRUCTURE,0) = 1.000000; -NODES[1467](IS_STRUCTURE,0) = 1.000000; -NODES[1480](IS_STRUCTURE,0) = 1.000000; -NODES[1485](IS_STRUCTURE,0) = 1.000000; -NODES[1500](IS_STRUCTURE,0) = 1.000000; -NODES[1517](IS_STRUCTURE,0) = 1.000000; -NODES[1527](IS_STRUCTURE,0) = 1.000000; -NODES[1534](IS_STRUCTURE,0) = 1.000000; -NODES[1550](IS_STRUCTURE,0) = 1.000000; -NODES[1566](IS_STRUCTURE,0) = 1.000000; -NODES[1571](IS_STRUCTURE,0) = 1.000000; -NODES[1584](IS_STRUCTURE,0) = 1.000000; -NODES[1602](IS_STRUCTURE,0) = 1.000000; -NODES[1611](IS_STRUCTURE,0) = 1.000000; -NODES[1622](IS_STRUCTURE,0) = 1.000000; -NODES[1639](IS_STRUCTURE,0) = 1.000000; -NODES[1651](IS_STRUCTURE,0) = 1.000000; -NODES[1656](IS_STRUCTURE,0) = 1.000000; -NODES[1677](IS_STRUCTURE,0) = 1.000000; -NODES[1690](IS_STRUCTURE,0) = 1.000000; -NODES[1693](IS_STRUCTURE,0) = 1.000000; -NODES[1712](IS_STRUCTURE,0) = 1.000000; -NODES[1729](IS_STRUCTURE,0) = 1.000000; -NODES[1730](IS_STRUCTURE,0) = 1.000000; -NODES[1747](IS_STRUCTURE,0) = 1.000000; -NODES[1765](IS_STRUCTURE,0) = 1.000000; -NODES[1767](IS_STRUCTURE,0) = 1.000000; -NODES[1784](IS_STRUCTURE,0) = 1.000000; -NODES[1803](IS_STRUCTURE,0) = 1.000000; -NODES[1804](IS_STRUCTURE,0) = 1.000000; -NODES[1822](IS_STRUCTURE,0) = 1.000000; -NODES[1839](IS_STRUCTURE,0) = 1.000000; -NODES[1840](IS_STRUCTURE,0) = 1.000000; -NODES[1857](IS_STRUCTURE,0) = 1.000000; -NODES[1873](IS_STRUCTURE,0) = 1.000000; -NODES[1876](IS_STRUCTURE,0) = 1.000000; -NODES[1894](IS_STRUCTURE,0) = 1.000000; -NODES[1909](IS_STRUCTURE,0) = 1.000000; -NODES[1913](IS_STRUCTURE,0) = 1.000000; -NODES[1932](IS_STRUCTURE,0) = 1.000000; -NODES[1943](IS_STRUCTURE,0) = 1.000000; -NODES[1950](IS_STRUCTURE,0) = 1.000000; -NODES[1969](IS_STRUCTURE,0) = 1.000000; -NODES[1975](IS_STRUCTURE,0) = 1.000000; -NODES[1988](IS_STRUCTURE,0) = 1.000000; -NODES[2008](IS_STRUCTURE,0) = 1.000000; -NODES[2010](IS_STRUCTURE,0) = 1.000000; -NODES[2025](IS_STRUCTURE,0) = 1.000000; -NODES[2043](IS_STRUCTURE,0) = 1.000000; -NODES[2045](IS_STRUCTURE,0) = 1.000000; -NODES[2064](IS_STRUCTURE,0) = 1.000000; -NODES[2077](IS_STRUCTURE,0) = 1.000000; -NODES[2086](IS_STRUCTURE,0) = 1.000000; -NODES[2102](IS_STRUCTURE,0) = 1.000000; -NODES[2110](IS_STRUCTURE,0) = 1.000000; -NODES[2124](IS_STRUCTURE,0) = 1.000000; -NODES[2143](IS_STRUCTURE,0) = 1.000000; -NODES[2144](IS_STRUCTURE,0) = 1.000000; -NODES[2166](IS_STRUCTURE,0) = 1.000000; -NODES[2176](IS_STRUCTURE,0) = 1.000000; -NODES[2186](IS_STRUCTURE,0) = 1.000000; -NODES[2205](IS_STRUCTURE,0) = 1.000000; -NODES[2208](IS_STRUCTURE,0) = 1.000000; -NODES[2226](IS_STRUCTURE,0) = 1.000000; -NODES[2240](IS_STRUCTURE,0) = 1.000000; -NODES[2246](IS_STRUCTURE,0) = 1.000000; -NODES[2267](IS_STRUCTURE,0) = 1.000000; -NODES[2272](IS_STRUCTURE,0) = 1.000000; -NODES[2287](IS_STRUCTURE,0) = 1.000000; -NODES[2303](IS_STRUCTURE,0) = 1.000000; -NODES[2308](IS_STRUCTURE,0) = 1.000000; -NODES[2326](IS_STRUCTURE,0) = 1.000000; -NODES[2336](IS_STRUCTURE,0) = 1.000000; -NODES[2349](IS_STRUCTURE,0) = 1.000000; -NODES[2367](IS_STRUCTURE,0) = 1.000000; -NODES[2369](IS_STRUCTURE,0) = 1.000000; -NODES[2389](IS_STRUCTURE,0) = 1.000000; -NODES[2397](IS_STRUCTURE,0) = 1.000000; -NODES[2411](IS_STRUCTURE,0) = 1.000000; -NODES[2428](IS_STRUCTURE,0) = 1.000000; -NODES[2433](IS_STRUCTURE,0) = 1.000000; -NODES[2451](IS_STRUCTURE,0) = 1.000000; -NODES[2462](IS_STRUCTURE,0) = 1.000000; -NODES[2472](IS_STRUCTURE,0) = 1.000000; -NODES[2492](IS_STRUCTURE,0) = 1.000000; -NODES[2494](IS_STRUCTURE,0) = 1.000000; -NODES[2515](IS_STRUCTURE,0) = 1.000000; -NODES[2522](IS_STRUCTURE,0) = 1.000000; -NODES[2537](IS_STRUCTURE,0) = 1.000000; -NODES[2551](IS_STRUCTURE,0) = 1.000000; -NODES[2557](IS_STRUCTURE,0) = 1.000000; -NODES[2578](IS_STRUCTURE,0) = 1.000000; -NODES[2582](IS_STRUCTURE,0) = 1.000000; -NODES[2598](IS_STRUCTURE,0) = 1.000000; -NODES[2612](IS_STRUCTURE,0) = 1.000000; -NODES[2620](IS_STRUCTURE,0) = 1.000000; -NODES[2640](IS_STRUCTURE,0) = 1.000000; -NODES[2642](IS_STRUCTURE,0) = 1.000000; -NODES[2662](IS_STRUCTURE,0) = 1.000000; -NODES[2671](IS_STRUCTURE,0) = 1.000000; -NODES[2684](IS_STRUCTURE,0) = 1.000000; -NODES[2702](IS_STRUCTURE,0) = 1.000000; -NODES[2705](IS_STRUCTURE,0) = 1.000000; -NODES[2725](IS_STRUCTURE,0) = 1.000000; -NODES[2731](IS_STRUCTURE,0) = 1.000000; -NODES[2746](IS_STRUCTURE,0) = 1.000000; -NODES[2760](IS_STRUCTURE,0) = 1.000000; -NODES[2767](IS_STRUCTURE,0) = 1.000000; -NODES[2788](IS_STRUCTURE,0) = 1.000000; -NODES[2789](IS_STRUCTURE,0) = 1.000000; -NODES[2811](IS_STRUCTURE,0) = 1.000000; -NODES[2817](IS_STRUCTURE,0) = 1.000000; -NODES[2832](IS_STRUCTURE,0) = 1.000000; -NODES[2848](IS_STRUCTURE,0) = 1.000000; -NODES[2855](IS_STRUCTURE,0) = 1.000000; -NODES[2876](IS_STRUCTURE,0) = 1.000000; -NODES[2878](IS_STRUCTURE,0) = 1.000000; -NODES[2896](IS_STRUCTURE,0) = 1.000000; -NODES[2905](IS_STRUCTURE,0) = 1.000000; -NODES[2918](IS_STRUCTURE,0) = 1.000000; -NODES[2932](IS_STRUCTURE,0) = 1.000000; -NODES[2939](IS_STRUCTURE,0) = 1.000000; -NODES[2959](IS_STRUCTURE,0) = 1.000000; -NODES[2962](IS_STRUCTURE,0) = 1.000000; -NODES[2981](IS_STRUCTURE,0) = 1.000000; -NODES[2991](IS_STRUCTURE,0) = 1.000000; -NODES[3004](IS_STRUCTURE,0) = 1.000000; -NODES[3020](IS_STRUCTURE,0) = 1.000000; -NODES[3026](IS_STRUCTURE,0) = 1.000000; -NODES[3048](IS_STRUCTURE,0) = 1.000000; -NODES[3049](IS_STRUCTURE,0) = 1.000000; -NODES[3069](IS_STRUCTURE,0) = 1.000000; -NODES[3075](IS_STRUCTURE,0) = 1.000000; -NODES[3091](IS_STRUCTURE,0) = 1.000000; -NODES[3102](IS_STRUCTURE,0) = 1.000000; -NODES[3114](IS_STRUCTURE,0) = 1.000000; -NODES[3131](IS_STRUCTURE,0) = 1.000000; -NODES[3136](IS_STRUCTURE,0) = 1.000000; -NODES[3156](IS_STRUCTURE,0) = 1.000000; -NODES[3161](IS_STRUCTURE,0) = 1.000000; -NODES[3174](IS_STRUCTURE,0) = 1.000000; -NODES[3188](IS_STRUCTURE,0) = 1.000000; -NODES[3196](IS_STRUCTURE,0) = 1.000000; -NODES[3215](IS_STRUCTURE,0) = 1.000000; -NODES[3219](IS_STRUCTURE,0) = 1.000000; -NODES[3241](IS_STRUCTURE,0) = 1.000000; -NODES[3242](IS_STRUCTURE,0) = 1.000000; -NODES[3263](IS_STRUCTURE,0) = 1.000000; -NODES[3267](IS_STRUCTURE,0) = 1.000000; -NODES[3286](IS_STRUCTURE,0) = 1.000000; -NODES[3292](IS_STRUCTURE,0) = 1.000000; -NODES[3308](IS_STRUCTURE,0) = 1.000000; -NODES[3323](IS_STRUCTURE,0) = 1.000000; -NODES[3328](IS_STRUCTURE,0) = 1.000000; -NODES[3348](IS_STRUCTURE,0) = 1.000000; -NODES[3349](IS_STRUCTURE,0) = 1.000000; -NODES[3370](IS_STRUCTURE,0) = 1.000000; -NODES[3375](IS_STRUCTURE,0) = 1.000000; -NODES[3393](IS_STRUCTURE,0) = 1.000000; -NODES[3401](IS_STRUCTURE,0) = 1.000000; -NODES[3414](IS_STRUCTURE,0) = 1.000000; -NODES[3426](IS_STRUCTURE,0) = 1.000000; -NODES[3436](IS_STRUCTURE,0) = 1.000000; -NODES[3457](IS_STRUCTURE,0) = 1.000000; -NODES[3459](IS_STRUCTURE,0) = 1.000000; -NODES[3477](IS_STRUCTURE,0) = 1.000000; -NODES[3485](IS_STRUCTURE,0) = 1.000000; -NODES[3495](IS_STRUCTURE,0) = 1.000000; -NODES[3512](IS_STRUCTURE,0) = 1.000000; -NODES[3518](IS_STRUCTURE,0) = 1.000000; -NODES[3538](IS_STRUCTURE,0) = 1.000000; -NODES[3541](IS_STRUCTURE,0) = 1.000000; -NODES[3563](IS_STRUCTURE,0) = 1.000000; -NODES[3564](IS_STRUCTURE,0) = 1.000000; -NODES[3586](IS_STRUCTURE,0) = 1.000000; -NODES[3587](IS_STRUCTURE,0) = 1.000000; -NODES[3609](IS_STRUCTURE,0) = 1.000000; -NODES[3617](IS_STRUCTURE,0) = 1.000000; -NODES[3632](IS_STRUCTURE,0) = 1.000000; -NODES[3648](IS_STRUCTURE,0) = 1.000000; -NODES[3649](IS_STRUCTURE,0) = 1.000000; -NODES[3650](IS_STRUCTURE,0) = 1.000000; -NODES[3651](IS_STRUCTURE,0) = 1.000000; -NODES[3653](IS_STRUCTURE,0) = 1.000000; -NODES[3654](IS_STRUCTURE,0) = 1.000000; -NODES[3656](IS_STRUCTURE,0) = 1.000000; -NODES[3657](IS_STRUCTURE,0) = 1.000000; -NODES[3659](IS_STRUCTURE,0) = 1.000000; -NODES[3661](IS_STRUCTURE,0) = 1.000000; -NODES[3664](IS_STRUCTURE,0) = 1.000000; -NODES[3665](IS_STRUCTURE,0) = 1.000000; -NODES[3666](IS_STRUCTURE,0) = 1.000000; -NODES[3667](IS_STRUCTURE,0) = 1.000000; -NODES[3668](IS_STRUCTURE,0) = 1.000000; -NODES[3669](IS_STRUCTURE,0) = 1.000000; -NODES[3670](IS_STRUCTURE,0) = 1.000000; -NODES[3671](IS_STRUCTURE,0) = 1.000000; -NODES[3683](IS_STRUCTURE,0) = 1.000000; -NODES[3689](IS_STRUCTURE,0) = 1.000000; -NODES[3692](IS_STRUCTURE,0) = 1.000000; -NODES[3694](IS_STRUCTURE,0) = 1.000000; -NODES[3697](IS_STRUCTURE,0) = 1.000000; -NODES[3698](IS_STRUCTURE,0) = 1.000000; -NODES[3699](IS_STRUCTURE,0) = 1.000000; -NODES[3700](IS_STRUCTURE,0) = 1.000000; -NODES[3705](IS_STRUCTURE,0) = 1.000000; -NODES[3716](IS_STRUCTURE,0) = 1.000000; -NODES[3721](IS_STRUCTURE,0) = 1.000000; -NODES[3724](IS_STRUCTURE,0) = 1.000000; -NODES[3725](IS_STRUCTURE,0) = 1.000000; -NODES[3727](IS_STRUCTURE,0) = 1.000000; -NODES[3729](IS_STRUCTURE,0) = 1.000000; -NODES[3735](IS_STRUCTURE,0) = 1.000000; -NODES[3745](IS_STRUCTURE,0) = 1.000000; -NODES[3750](IS_STRUCTURE,0) = 1.000000; -NODES[3751](IS_STRUCTURE,0) = 1.000000; -NODES[3754](IS_STRUCTURE,0) = 1.000000; -NODES[3755](IS_STRUCTURE,0) = 1.000000; -NODES[3765](IS_STRUCTURE,0) = 1.000000; -NODES[3774](IS_STRUCTURE,0) = 1.000000; -NODES[3777](IS_STRUCTURE,0) = 1.000000; -NODES[3778](IS_STRUCTURE,0) = 1.000000; -NODES[3782](IS_STRUCTURE,0) = 1.000000; -NODES[3783](IS_STRUCTURE,0) = 1.000000; -NODES[3799](IS_STRUCTURE,0) = 1.000000; -NODES[3803](IS_STRUCTURE,0) = 1.000000; -NODES[3805](IS_STRUCTURE,0) = 1.000000; -NODES[3807](IS_STRUCTURE,0) = 1.000000; -NODES[3810](IS_STRUCTURE,0) = 1.000000; -NODES[3824](IS_STRUCTURE,0) = 1.000000; -NODES[3826](IS_STRUCTURE,0) = 1.000000; -NODES[3831](IS_STRUCTURE,0) = 1.000000; -NODES[3833](IS_STRUCTURE,0) = 1.000000; -NODES[3843](IS_STRUCTURE,0) = 1.000000; -NODES[3851](IS_STRUCTURE,0) = 1.000000; -NODES[3852](IS_STRUCTURE,0) = 1.000000; -NODES[3857](IS_STRUCTURE,0) = 1.000000; -NODES[3862](IS_STRUCTURE,0) = 1.000000; -NODES[3874](IS_STRUCTURE,0) = 1.000000; -NODES[3875](IS_STRUCTURE,0) = 1.000000; -NODES[3879](IS_STRUCTURE,0) = 1.000000; -NODES[3888](IS_STRUCTURE,0) = 1.000000; -NODES[3898](IS_STRUCTURE,0) = 1.000000; -NODES[3900](IS_STRUCTURE,0) = 1.000000; -NODES[3905](IS_STRUCTURE,0) = 1.000000; -NODES[3912](IS_STRUCTURE,0) = 1.000000; -NODES[3919](IS_STRUCTURE,0) = 1.000000; -NODES[3923](IS_STRUCTURE,0) = 1.000000; -NODES[3931](IS_STRUCTURE,0) = 1.000000; -NODES[3939](IS_STRUCTURE,0) = 1.000000; -NODES[3945](IS_STRUCTURE,0) = 1.000000; -NODES[3950](IS_STRUCTURE,0) = 1.000000; -NODES[3957](IS_STRUCTURE,0) = 1.000000; -NODES[3965](IS_STRUCTURE,0) = 1.000000; -NODES[3968](IS_STRUCTURE,0) = 1.000000; -NODES[3976](IS_STRUCTURE,0) = 1.000000; -NODES[3986](IS_STRUCTURE,0) = 1.000000; -NODES[3990](IS_STRUCTURE,0) = 1.000000; -NODES[3995](IS_STRUCTURE,0) = 1.000000; -NODES[4003](IS_STRUCTURE,0) = 1.000000; -NODES[4014](IS_STRUCTURE,0) = 1.000000; -NODES[4015](IS_STRUCTURE,0) = 1.000000; -NODES[4024](IS_STRUCTURE,0) = 1.000000; -NODES[4033](IS_STRUCTURE,0) = 1.000000; -NODES[4039](IS_STRUCTURE,0) = 1.000000; -NODES[4044](IS_STRUCTURE,0) = 1.000000; -NODES[4053](IS_STRUCTURE,0) = 1.000000; -NODES[4061](IS_STRUCTURE,0) = 1.000000; -NODES[4065](IS_STRUCTURE,0) = 1.000000; -NODES[4072](IS_STRUCTURE,0) = 1.000000; -NODES[4086](IS_STRUCTURE,0) = 1.000000; -NODES[4087](IS_STRUCTURE,0) = 1.000000; -NODES[4094](IS_STRUCTURE,0) = 1.000000; -NODES[4106](IS_STRUCTURE,0) = 1.000000; -NODES[4109](IS_STRUCTURE,0) = 1.000000; -NODES[4118](IS_STRUCTURE,0) = 1.000000; -NODES[4128](IS_STRUCTURE,0) = 1.000000; -NODES[4132](IS_STRUCTURE,0) = 1.000000; -NODES[4139](IS_STRUCTURE,0) = 1.000000; -NODES[4149](IS_STRUCTURE,0) = 1.000000; -NODES[4157](IS_STRUCTURE,0) = 1.000000; -NODES[4163](IS_STRUCTURE,0) = 1.000000; -NODES[4173](IS_STRUCTURE,0) = 1.000000; -NODES[4180](IS_STRUCTURE,0) = 1.000000; -NODES[4186](IS_STRUCTURE,0) = 1.000000; -NODES[4196](IS_STRUCTURE,0) = 1.000000; -NODES[4201](IS_STRUCTURE,0) = 1.000000; -NODES[4207](IS_STRUCTURE,0) = 1.000000; -NODES[4214](IS_STRUCTURE,0) = 1.000000; -NODES[4222](IS_STRUCTURE,0) = 1.000000; -NODES[4226](IS_STRUCTURE,0) = 1.000000; -NODES[4234](IS_STRUCTURE,0) = 1.000000; -NODES[4240](IS_STRUCTURE,0) = 1.000000; -NODES[4242](IS_STRUCTURE,0) = 1.000000; -NODES[4248](IS_STRUCTURE,0) = 1.000000; -NODES[4255](IS_STRUCTURE,0) = 1.000000; -NODES[4257](IS_STRUCTURE,0) = 1.000000; -NODES[4263](IS_STRUCTURE,0) = 1.000000; -NODES[4268](IS_STRUCTURE,0) = 1.000000; -NODES[4270](IS_STRUCTURE,0) = 1.000000; -NODES[4275](IS_STRUCTURE,0) = 1.000000; -NODES[4276](IS_STRUCTURE,0) = 1.000000; -NODES[4281](IS_STRUCTURE,0) = 1.000000; -NODES[4284](IS_STRUCTURE,0) = 1.000000; -NODES[4286](IS_STRUCTURE,0) = 1.000000; -NODES[4289](IS_STRUCTURE,0) = 1.000000; -NODES[4292](IS_STRUCTURE,0) = 1.000000; -NODES[4293](IS_STRUCTURE,0) = 1.000000; -NODES[4295](IS_STRUCTURE,0) = 1.000000; -NODES[4296](IS_STRUCTURE,0) = 1.000000; -NODES[4297](IS_STRUCTURE,0) = 1.000000; -NODES[4298](IS_STRUCTURE,0) = 1.000000; -NODES[4299](IS_STRUCTURE,0) = 1.000000; -NODES[1](VELOCITY_X,0) = 0.000000; -NODES[1](VELOCITY_Y,0) = 0.000000; -NODES[1](VELOCITY_Z,0) = 0.000000; -NODES[2](VELOCITY_X,0) = 0.000000; -NODES[2](VELOCITY_Y,0) = 0.000000; -NODES[2](VELOCITY_Z,0) = 0.000000; -NODES[3](VELOCITY_X,0) = 0.000000; -NODES[3](VELOCITY_Y,0) = 0.000000; -NODES[3](VELOCITY_Z,0) = 0.000000; -NODES[4](VELOCITY_X,0) = 0.000000; -NODES[4](VELOCITY_Y,0) = 0.000000; -NODES[4](VELOCITY_Z,0) = 0.000000; -NODES[5](VELOCITY_X,0) = 0.000000; -NODES[5](VELOCITY_Y,0) = 0.000000; -NODES[5](VELOCITY_Z,0) = 0.000000; -NODES[6](VELOCITY_X,0) = 0.000000; -NODES[6](VELOCITY_Y,0) = 0.000000; -NODES[6](VELOCITY_Z,0) = 0.000000; -NODES[7](VELOCITY_X,0) = 0.000000; -NODES[7](VELOCITY_Y,0) = 0.000000; -NODES[7](VELOCITY_Z,0) = 0.000000; -NODES[8](VELOCITY_X,0) = 0.000000; -NODES[8](VELOCITY_Y,0) = 0.000000; -NODES[8](VELOCITY_Z,0) = 0.000000; -NODES[9](VELOCITY_X,0) = 0.000000; -NODES[9](VELOCITY_Y,0) = 0.000000; -NODES[9](VELOCITY_Z,0) = 0.000000; -NODES[10](VELOCITY_X,0) = 0.000000; -NODES[10](VELOCITY_Y,0) = 0.000000; -NODES[10](VELOCITY_Z,0) = 0.000000; -NODES[11](VELOCITY_X,0) = 0.000000; -NODES[11](VELOCITY_Y,0) = 0.000000; -NODES[11](VELOCITY_Z,0) = 0.000000; -NODES[12](VELOCITY_X,0) = 0.000000; -NODES[12](VELOCITY_Y,0) = 0.000000; -NODES[12](VELOCITY_Z,0) = 0.000000; -NODES[13](VELOCITY_X,0) = 0.000000; -NODES[13](VELOCITY_Y,0) = 0.000000; -NODES[13](VELOCITY_Z,0) = 0.000000; -NODES[14](VELOCITY_X,0) = 0.000000; -NODES[14](VELOCITY_Y,0) = 0.000000; -NODES[14](VELOCITY_Z,0) = 0.000000; -NODES[15](VELOCITY_X,0) = 0.000000; -NODES[15](VELOCITY_Y,0) = 0.000000; -NODES[15](VELOCITY_Z,0) = 0.000000; -NODES[16](VELOCITY_X,0) = 0.000000; -NODES[16](VELOCITY_Y,0) = 0.000000; -NODES[16](VELOCITY_Z,0) = 0.000000; -NODES[17](VELOCITY_X,0) = 0.000000; -NODES[17](VELOCITY_Y,0) = 0.000000; -NODES[17](VELOCITY_Z,0) = 0.000000; -NODES[18](VELOCITY_X,0) = 0.000000; -NODES[18](VELOCITY_Y,0) = 0.000000; -NODES[18](VELOCITY_Z,0) = 0.000000; -NODES[19](VELOCITY_X,0) = 0.000000; -NODES[19](VELOCITY_Y,0) = 0.000000; -NODES[19](VELOCITY_Z,0) = 0.000000; -NODES[20](VELOCITY_X,0) = 0.000000; -NODES[20](VELOCITY_Y,0) = 0.000000; -NODES[20](VELOCITY_Z,0) = 0.000000; -NODES[21](VELOCITY_X,0) = 0.000000; -NODES[21](VELOCITY_Y,0) = 0.000000; -NODES[21](VELOCITY_Z,0) = 0.000000; -NODES[22](VELOCITY_X,0) = 0.000000; -NODES[22](VELOCITY_Y,0) = 0.000000; -NODES[22](VELOCITY_Z,0) = 0.000000; -NODES[23](VELOCITY_X,0) = 0.000000; -NODES[23](VELOCITY_Y,0) = 0.000000; -NODES[23](VELOCITY_Z,0) = 0.000000; -NODES[24](VELOCITY_X,0) = 0.000000; -NODES[24](VELOCITY_Y,0) = 0.000000; -NODES[24](VELOCITY_Z,0) = 0.000000; -NODES[25](VELOCITY_X,0) = 0.000000; -NODES[25](VELOCITY_Y,0) = 0.000000; -NODES[25](VELOCITY_Z,0) = 0.000000; -NODES[26](VELOCITY_X,0) = 0.000000; -NODES[26](VELOCITY_Y,0) = 0.000000; -NODES[26](VELOCITY_Z,0) = 0.000000; -NODES[27](VELOCITY_X,0) = 0.000000; -NODES[27](VELOCITY_Y,0) = 0.000000; -NODES[27](VELOCITY_Z,0) = 0.000000; -NODES[28](VELOCITY_X,0) = 0.000000; -NODES[28](VELOCITY_Y,0) = 0.000000; -NODES[28](VELOCITY_Z,0) = 0.000000; -NODES[29](VELOCITY_X,0) = 0.000000; -NODES[29](VELOCITY_Y,0) = 0.000000; -NODES[29](VELOCITY_Z,0) = 0.000000; -NODES[30](VELOCITY_X,0) = 0.000000; -NODES[30](VELOCITY_Y,0) = 0.000000; -NODES[30](VELOCITY_Z,0) = 0.000000; -NODES[31](VELOCITY_X,0) = 0.000000; -NODES[31](VELOCITY_Y,0) = 0.000000; -NODES[31](VELOCITY_Z,0) = 0.000000; -NODES[32](VELOCITY_X,0) = 0.000000; -NODES[32](VELOCITY_Y,0) = 0.000000; -NODES[32](VELOCITY_Z,0) = 0.000000; -NODES[33](VELOCITY_X,0) = 0.000000; -NODES[33](VELOCITY_Y,0) = 0.000000; -NODES[33](VELOCITY_Z,0) = 0.000000; -NODES[34](VELOCITY_X,0) = 0.000000; -NODES[34](VELOCITY_Y,0) = 0.000000; -NODES[34](VELOCITY_Z,0) = 0.000000; -NODES[35](VELOCITY_X,0) = 0.000000; -NODES[35](VELOCITY_Y,0) = 0.000000; -NODES[35](VELOCITY_Z,0) = 0.000000; -NODES[36](VELOCITY_X,0) = 0.000000; -NODES[36](VELOCITY_Y,0) = 0.000000; -NODES[36](VELOCITY_Z,0) = 0.000000; -NODES[37](VELOCITY_X,0) = 0.000000; -NODES[37](VELOCITY_Y,0) = 0.000000; -NODES[37](VELOCITY_Z,0) = 0.000000; -NODES[38](VELOCITY_X,0) = 0.000000; -NODES[38](VELOCITY_Y,0) = 0.000000; -NODES[38](VELOCITY_Z,0) = 0.000000; -NODES[39](VELOCITY_X,0) = 0.000000; -NODES[39](VELOCITY_Y,0) = 0.000000; -NODES[39](VELOCITY_Z,0) = 0.000000; -NODES[40](VELOCITY_X,0) = 0.000000; -NODES[40](VELOCITY_Y,0) = 0.000000; -NODES[40](VELOCITY_Z,0) = 0.000000; -NODES[41](VELOCITY_X,0) = 0.000000; -NODES[41](VELOCITY_Y,0) = 0.000000; -NODES[41](VELOCITY_Z,0) = 0.000000; -NODES[42](VELOCITY_X,0) = 0.000000; -NODES[42](VELOCITY_Y,0) = 0.000000; -NODES[42](VELOCITY_Z,0) = 0.000000; -NODES[43](VELOCITY_X,0) = 0.000000; -NODES[43](VELOCITY_Y,0) = 0.000000; -NODES[43](VELOCITY_Z,0) = 0.000000; -NODES[44](VELOCITY_X,0) = 0.000000; -NODES[44](VELOCITY_Y,0) = 0.000000; -NODES[44](VELOCITY_Z,0) = 0.000000; -NODES[45](VELOCITY_X,0) = 0.000000; -NODES[45](VELOCITY_Y,0) = 0.000000; -NODES[45](VELOCITY_Z,0) = 0.000000; -NODES[46](VELOCITY_X,0) = 0.000000; -NODES[46](VELOCITY_Y,0) = 0.000000; -NODES[46](VELOCITY_Z,0) = 0.000000; -NODES[47](VELOCITY_X,0) = 0.000000; -NODES[47](VELOCITY_Y,0) = 0.000000; -NODES[47](VELOCITY_Z,0) = 0.000000; -NODES[48](VELOCITY_X,0) = 0.000000; -NODES[48](VELOCITY_Y,0) = 0.000000; -NODES[48](VELOCITY_Z,0) = 0.000000; -NODES[49](VELOCITY_X,0) = 0.000000; -NODES[49](VELOCITY_Y,0) = 0.000000; -NODES[49](VELOCITY_Z,0) = 0.000000; -NODES[50](VELOCITY_X,0) = 0.000000; -NODES[50](VELOCITY_Y,0) = 0.000000; -NODES[50](VELOCITY_Z,0) = 0.000000; -NODES[51](VELOCITY_X,0) = 0.000000; -NODES[51](VELOCITY_Y,0) = 0.000000; -NODES[51](VELOCITY_Z,0) = 0.000000; -NODES[52](VELOCITY_X,0) = 0.000000; -NODES[52](VELOCITY_Y,0) = 0.000000; -NODES[52](VELOCITY_Z,0) = 0.000000; -NODES[53](VELOCITY_X,0) = 0.000000; -NODES[53](VELOCITY_Y,0) = 0.000000; -NODES[53](VELOCITY_Z,0) = 0.000000; -NODES[54](VELOCITY_X,0) = 0.000000; -NODES[54](VELOCITY_Y,0) = 0.000000; -NODES[54](VELOCITY_Z,0) = 0.000000; -NODES[55](VELOCITY_X,0) = 0.000000; -NODES[55](VELOCITY_Y,0) = 0.000000; -NODES[55](VELOCITY_Z,0) = 0.000000; -NODES[56](VELOCITY_X,0) = 0.000000; -NODES[56](VELOCITY_Y,0) = 0.000000; -NODES[56](VELOCITY_Z,0) = 0.000000; -NODES[57](VELOCITY_X,0) = 0.000000; -NODES[57](VELOCITY_Y,0) = 0.000000; -NODES[57](VELOCITY_Z,0) = 0.000000; -NODES[58](VELOCITY_X,0) = 0.000000; -NODES[58](VELOCITY_Y,0) = 0.000000; -NODES[58](VELOCITY_Z,0) = 0.000000; -NODES[59](VELOCITY_X,0) = 0.000000; -NODES[59](VELOCITY_Y,0) = 0.000000; -NODES[59](VELOCITY_Z,0) = 0.000000; -NODES[60](VELOCITY_X,0) = 0.000000; -NODES[60](VELOCITY_Y,0) = 0.000000; -NODES[60](VELOCITY_Z,0) = 0.000000; -NODES[61](VELOCITY_X,0) = 0.000000; -NODES[61](VELOCITY_Y,0) = 0.000000; -NODES[61](VELOCITY_Z,0) = 0.000000; -NODES[62](VELOCITY_X,0) = 0.000000; -NODES[62](VELOCITY_Y,0) = 0.000000; -NODES[62](VELOCITY_Z,0) = 0.000000; -NODES[63](VELOCITY_X,0) = 0.000000; -NODES[63](VELOCITY_Y,0) = 0.000000; -NODES[63](VELOCITY_Z,0) = 0.000000; -NODES[64](VELOCITY_X,0) = 0.000000; -NODES[64](VELOCITY_Y,0) = 0.000000; -NODES[64](VELOCITY_Z,0) = 0.000000; -NODES[65](VELOCITY_X,0) = 0.000000; -NODES[65](VELOCITY_Y,0) = 0.000000; -NODES[65](VELOCITY_Z,0) = 0.000000; -NODES[66](VELOCITY_X,0) = 0.000000; -NODES[66](VELOCITY_Y,0) = 0.000000; -NODES[66](VELOCITY_Z,0) = 0.000000; -NODES[67](VELOCITY_X,0) = 0.000000; -NODES[67](VELOCITY_Y,0) = 0.000000; -NODES[67](VELOCITY_Z,0) = 0.000000; -NODES[68](VELOCITY_X,0) = 0.000000; -NODES[68](VELOCITY_Y,0) = 0.000000; -NODES[68](VELOCITY_Z,0) = 0.000000; -NODES[69](VELOCITY_X,0) = 0.000000; -NODES[69](VELOCITY_Y,0) = 0.000000; -NODES[69](VELOCITY_Z,0) = 0.000000; -NODES[70](VELOCITY_X,0) = 0.000000; -NODES[70](VELOCITY_Y,0) = 0.000000; -NODES[70](VELOCITY_Z,0) = 0.000000; -NODES[71](VELOCITY_X,0) = 0.000000; -NODES[71](VELOCITY_Y,0) = 0.000000; -NODES[71](VELOCITY_Z,0) = 0.000000; -NODES[72](VELOCITY_X,0) = 0.000000; -NODES[72](VELOCITY_Y,0) = 0.000000; -NODES[72](VELOCITY_Z,0) = 0.000000; -NODES[73](VELOCITY_X,0) = 0.000000; -NODES[73](VELOCITY_Y,0) = 0.000000; -NODES[73](VELOCITY_Z,0) = 0.000000; -NODES[74](VELOCITY_X,0) = 0.000000; -NODES[74](VELOCITY_Y,0) = 0.000000; -NODES[74](VELOCITY_Z,0) = 0.000000; -NODES[75](VELOCITY_X,0) = 0.000000; -NODES[75](VELOCITY_Y,0) = 0.000000; -NODES[75](VELOCITY_Z,0) = 0.000000; -NODES[76](VELOCITY_X,0) = 0.000000; -NODES[76](VELOCITY_Y,0) = 0.000000; -NODES[76](VELOCITY_Z,0) = 0.000000; -NODES[77](VELOCITY_X,0) = 0.000000; -NODES[77](VELOCITY_Y,0) = 0.000000; -NODES[77](VELOCITY_Z,0) = 0.000000; -NODES[78](VELOCITY_X,0) = 0.000000; -NODES[78](VELOCITY_Y,0) = 0.000000; -NODES[78](VELOCITY_Z,0) = 0.000000; -NODES[79](VELOCITY_X,0) = 0.000000; -NODES[79](VELOCITY_Y,0) = 0.000000; -NODES[79](VELOCITY_Z,0) = 0.000000; -NODES[80](VELOCITY_X,0) = 0.000000; -NODES[80](VELOCITY_Y,0) = 0.000000; -NODES[80](VELOCITY_Z,0) = 0.000000; -NODES[81](VELOCITY_X,0) = 0.000000; -NODES[81](VELOCITY_Y,0) = 0.000000; -NODES[81](VELOCITY_Z,0) = 0.000000; -NODES[82](VELOCITY_X,0) = 0.000000; -NODES[82](VELOCITY_Y,0) = 0.000000; -NODES[82](VELOCITY_Z,0) = 0.000000; -NODES[83](VELOCITY_X,0) = 0.000000; -NODES[83](VELOCITY_Y,0) = 0.000000; -NODES[83](VELOCITY_Z,0) = 0.000000; -NODES[84](VELOCITY_X,0) = 0.000000; -NODES[84](VELOCITY_Y,0) = 0.000000; -NODES[84](VELOCITY_Z,0) = 0.000000; -NODES[85](VELOCITY_X,0) = 0.000000; -NODES[85](VELOCITY_Y,0) = 0.000000; -NODES[85](VELOCITY_Z,0) = 0.000000; -NODES[86](VELOCITY_X,0) = 0.000000; -NODES[86](VELOCITY_Y,0) = 0.000000; -NODES[86](VELOCITY_Z,0) = 0.000000; -NODES[87](VELOCITY_X,0) = 0.000000; -NODES[87](VELOCITY_Y,0) = 0.000000; -NODES[87](VELOCITY_Z,0) = 0.000000; -NODES[88](VELOCITY_X,0) = 0.000000; -NODES[88](VELOCITY_Y,0) = 0.000000; -NODES[88](VELOCITY_Z,0) = 0.000000; -NODES[89](VELOCITY_X,0) = 0.000000; -NODES[89](VELOCITY_Y,0) = 0.000000; -NODES[89](VELOCITY_Z,0) = 0.000000; -NODES[90](VELOCITY_X,0) = 0.000000; -NODES[90](VELOCITY_Y,0) = 0.000000; -NODES[90](VELOCITY_Z,0) = 0.000000; -NODES[91](VELOCITY_X,0) = 0.000000; -NODES[91](VELOCITY_Y,0) = 0.000000; -NODES[91](VELOCITY_Z,0) = 0.000000; -NODES[92](VELOCITY_X,0) = 0.000000; -NODES[92](VELOCITY_Y,0) = 0.000000; -NODES[92](VELOCITY_Z,0) = 0.000000; -NODES[93](VELOCITY_X,0) = 0.000000; -NODES[93](VELOCITY_Y,0) = 0.000000; -NODES[93](VELOCITY_Z,0) = 0.000000; -NODES[94](VELOCITY_X,0) = 0.000000; -NODES[94](VELOCITY_Y,0) = 0.000000; -NODES[94](VELOCITY_Z,0) = 0.000000; -NODES[95](VELOCITY_X,0) = 0.000000; -NODES[95](VELOCITY_Y,0) = 0.000000; -NODES[95](VELOCITY_Z,0) = 0.000000; -NODES[96](VELOCITY_X,0) = 0.000000; -NODES[96](VELOCITY_Y,0) = 0.000000; -NODES[96](VELOCITY_Z,0) = 0.000000; -NODES[97](VELOCITY_X,0) = 0.000000; -NODES[97](VELOCITY_Y,0) = 0.000000; -NODES[97](VELOCITY_Z,0) = 0.000000; -NODES[98](VELOCITY_X,0) = 0.000000; -NODES[98](VELOCITY_Y,0) = 0.000000; -NODES[98](VELOCITY_Z,0) = 0.000000; -NODES[99](VELOCITY_X,0) = 0.000000; -NODES[99](VELOCITY_Y,0) = 0.000000; -NODES[99](VELOCITY_Z,0) = 0.000000; -NODES[100](VELOCITY_X,0) = 0.000000; -NODES[100](VELOCITY_Y,0) = 0.000000; -NODES[100](VELOCITY_Z,0) = 0.000000; -NODES[101](VELOCITY_X,0) = 0.000000; -NODES[101](VELOCITY_Y,0) = 0.000000; -NODES[101](VELOCITY_Z,0) = 0.000000; -NODES[102](VELOCITY_X,0) = 0.000000; -NODES[102](VELOCITY_Y,0) = 0.000000; -NODES[102](VELOCITY_Z,0) = 0.000000; -NODES[103](VELOCITY_X,0) = 0.000000; -NODES[103](VELOCITY_Y,0) = 0.000000; -NODES[103](VELOCITY_Z,0) = 0.000000; -NODES[104](VELOCITY_X,0) = 0.000000; -NODES[104](VELOCITY_Y,0) = 0.000000; -NODES[104](VELOCITY_Z,0) = 0.000000; -NODES[105](VELOCITY_X,0) = 0.000000; -NODES[105](VELOCITY_Y,0) = 0.000000; -NODES[105](VELOCITY_Z,0) = 0.000000; -NODES[106](VELOCITY_X,0) = 0.000000; -NODES[106](VELOCITY_Y,0) = 0.000000; -NODES[106](VELOCITY_Z,0) = 0.000000; -NODES[107](VELOCITY_X,0) = 0.000000; -NODES[107](VELOCITY_Y,0) = 0.000000; -NODES[107](VELOCITY_Z,0) = 0.000000; -NODES[108](VELOCITY_X,0) = 0.000000; -NODES[108](VELOCITY_Y,0) = 0.000000; -NODES[108](VELOCITY_Z,0) = 0.000000; -NODES[109](VELOCITY_X,0) = 0.000000; -NODES[109](VELOCITY_Y,0) = 0.000000; -NODES[109](VELOCITY_Z,0) = 0.000000; -NODES[110](VELOCITY_X,0) = 0.000000; -NODES[110](VELOCITY_Y,0) = 0.000000; -NODES[110](VELOCITY_Z,0) = 0.000000; -NODES[111](VELOCITY_X,0) = 0.000000; -NODES[111](VELOCITY_Y,0) = 0.000000; -NODES[111](VELOCITY_Z,0) = 0.000000; -NODES[112](VELOCITY_X,0) = 0.000000; -NODES[112](VELOCITY_Y,0) = 0.000000; -NODES[112](VELOCITY_Z,0) = 0.000000; -NODES[113](VELOCITY_X,0) = 0.000000; -NODES[113](VELOCITY_Y,0) = 0.000000; -NODES[113](VELOCITY_Z,0) = 0.000000; -NODES[114](VELOCITY_X,0) = 0.000000; -NODES[114](VELOCITY_Y,0) = 0.000000; -NODES[114](VELOCITY_Z,0) = 0.000000; -NODES[115](VELOCITY_X,0) = 0.000000; -NODES[115](VELOCITY_Y,0) = 0.000000; -NODES[115](VELOCITY_Z,0) = 0.000000; -NODES[116](VELOCITY_X,0) = 0.000000; -NODES[116](VELOCITY_Y,0) = 0.000000; -NODES[116](VELOCITY_Z,0) = 0.000000; -NODES[117](VELOCITY_X,0) = 0.000000; -NODES[117](VELOCITY_Y,0) = 0.000000; -NODES[117](VELOCITY_Z,0) = 0.000000; -NODES[118](VELOCITY_X,0) = 0.000000; -NODES[118](VELOCITY_Y,0) = 0.000000; -NODES[118](VELOCITY_Z,0) = 0.000000; -NODES[119](VELOCITY_X,0) = 0.000000; -NODES[119](VELOCITY_Y,0) = 0.000000; -NODES[119](VELOCITY_Z,0) = 0.000000; -NODES[120](VELOCITY_X,0) = 0.000000; -NODES[120](VELOCITY_Y,0) = 0.000000; -NODES[120](VELOCITY_Z,0) = 0.000000; -NODES[121](VELOCITY_X,0) = 0.000000; -NODES[121](VELOCITY_Y,0) = 0.000000; -NODES[121](VELOCITY_Z,0) = 0.000000; -NODES[122](VELOCITY_X,0) = 0.000000; -NODES[122](VELOCITY_Y,0) = 0.000000; -NODES[122](VELOCITY_Z,0) = 0.000000; -NODES[123](VELOCITY_X,0) = 0.000000; -NODES[123](VELOCITY_Y,0) = 0.000000; -NODES[123](VELOCITY_Z,0) = 0.000000; -NODES[124](VELOCITY_X,0) = 0.000000; -NODES[124](VELOCITY_Y,0) = 0.000000; -NODES[124](VELOCITY_Z,0) = 0.000000; -NODES[125](VELOCITY_X,0) = 0.000000; -NODES[125](VELOCITY_Y,0) = 0.000000; -NODES[125](VELOCITY_Z,0) = 0.000000; -NODES[126](VELOCITY_X,0) = 0.000000; -NODES[126](VELOCITY_Y,0) = 0.000000; -NODES[126](VELOCITY_Z,0) = 0.000000; -NODES[127](VELOCITY_X,0) = 0.000000; -NODES[127](VELOCITY_Y,0) = 0.000000; -NODES[127](VELOCITY_Z,0) = 0.000000; -NODES[128](VELOCITY_X,0) = 0.000000; -NODES[128](VELOCITY_Y,0) = 0.000000; -NODES[128](VELOCITY_Z,0) = 0.000000; -NODES[129](VELOCITY_X,0) = 0.000000; -NODES[129](VELOCITY_Y,0) = 0.000000; -NODES[129](VELOCITY_Z,0) = 0.000000; -NODES[130](VELOCITY_X,0) = 0.000000; -NODES[130](VELOCITY_Y,0) = 0.000000; -NODES[130](VELOCITY_Z,0) = 0.000000; -NODES[131](VELOCITY_X,0) = 0.000000; -NODES[131](VELOCITY_Y,0) = 0.000000; -NODES[131](VELOCITY_Z,0) = 0.000000; -NODES[132](VELOCITY_X,0) = 0.000000; -NODES[132](VELOCITY_Y,0) = 0.000000; -NODES[132](VELOCITY_Z,0) = 0.000000; -NODES[133](VELOCITY_X,0) = 0.000000; -NODES[133](VELOCITY_Y,0) = 0.000000; -NODES[133](VELOCITY_Z,0) = 0.000000; -NODES[134](VELOCITY_X,0) = 0.000000; -NODES[134](VELOCITY_Y,0) = 0.000000; -NODES[134](VELOCITY_Z,0) = 0.000000; -NODES[135](VELOCITY_X,0) = 0.000000; -NODES[135](VELOCITY_Y,0) = 0.000000; -NODES[135](VELOCITY_Z,0) = 0.000000; -NODES[136](VELOCITY_X,0) = 0.000000; -NODES[136](VELOCITY_Y,0) = 0.000000; -NODES[136](VELOCITY_Z,0) = 0.000000; -NODES[137](VELOCITY_X,0) = 0.000000; -NODES[137](VELOCITY_Y,0) = 0.000000; -NODES[137](VELOCITY_Z,0) = 0.000000; -NODES[138](VELOCITY_X,0) = 0.000000; -NODES[138](VELOCITY_Y,0) = 0.000000; -NODES[138](VELOCITY_Z,0) = 0.000000; -NODES[139](VELOCITY_X,0) = 0.000000; -NODES[139](VELOCITY_Y,0) = 0.000000; -NODES[139](VELOCITY_Z,0) = 0.000000; -NODES[140](VELOCITY_X,0) = 0.000000; -NODES[140](VELOCITY_Y,0) = 0.000000; -NODES[140](VELOCITY_Z,0) = 0.000000; -NODES[141](VELOCITY_X,0) = 0.000000; -NODES[141](VELOCITY_Y,0) = 0.000000; -NODES[141](VELOCITY_Z,0) = 0.000000; -NODES[142](VELOCITY_X,0) = 0.000000; -NODES[142](VELOCITY_Y,0) = 0.000000; -NODES[142](VELOCITY_Z,0) = 0.000000; -NODES[143](VELOCITY_X,0) = 0.000000; -NODES[143](VELOCITY_Y,0) = 0.000000; -NODES[143](VELOCITY_Z,0) = 0.000000; -NODES[144](VELOCITY_X,0) = 0.000000; -NODES[144](VELOCITY_Y,0) = 0.000000; -NODES[144](VELOCITY_Z,0) = 0.000000; -NODES[145](VELOCITY_X,0) = 0.000000; -NODES[145](VELOCITY_Y,0) = 0.000000; -NODES[145](VELOCITY_Z,0) = 0.000000; -NODES[146](VELOCITY_X,0) = 0.000000; -NODES[146](VELOCITY_Y,0) = 0.000000; -NODES[146](VELOCITY_Z,0) = 0.000000; -NODES[147](VELOCITY_X,0) = 0.000000; -NODES[147](VELOCITY_Y,0) = 0.000000; -NODES[147](VELOCITY_Z,0) = 0.000000; -NODES[148](VELOCITY_X,0) = 0.000000; -NODES[148](VELOCITY_Y,0) = 0.000000; -NODES[148](VELOCITY_Z,0) = 0.000000; -NODES[149](VELOCITY_X,0) = 0.000000; -NODES[149](VELOCITY_Y,0) = 0.000000; -NODES[149](VELOCITY_Z,0) = 0.000000; -NODES[150](VELOCITY_X,0) = 0.000000; -NODES[150](VELOCITY_Y,0) = 0.000000; -NODES[150](VELOCITY_Z,0) = 0.000000; -NODES[151](VELOCITY_X,0) = 0.000000; -NODES[151](VELOCITY_Y,0) = 0.000000; -NODES[151](VELOCITY_Z,0) = 0.000000; -NODES[152](VELOCITY_X,0) = 0.000000; -NODES[152](VELOCITY_Y,0) = 0.000000; -NODES[152](VELOCITY_Z,0) = 0.000000; -NODES[153](VELOCITY_X,0) = 0.000000; -NODES[153](VELOCITY_Y,0) = 0.000000; -NODES[153](VELOCITY_Z,0) = 0.000000; -NODES[154](VELOCITY_X,0) = 0.000000; -NODES[154](VELOCITY_Y,0) = 0.000000; -NODES[154](VELOCITY_Z,0) = 0.000000; -NODES[155](VELOCITY_X,0) = 0.000000; -NODES[155](VELOCITY_Y,0) = 0.000000; -NODES[155](VELOCITY_Z,0) = 0.000000; -NODES[156](VELOCITY_X,0) = 0.000000; -NODES[156](VELOCITY_Y,0) = 0.000000; -NODES[156](VELOCITY_Z,0) = 0.000000; -NODES[157](VELOCITY_X,0) = 0.000000; -NODES[157](VELOCITY_Y,0) = 0.000000; -NODES[157](VELOCITY_Z,0) = 0.000000; -NODES[158](VELOCITY_X,0) = 0.000000; -NODES[158](VELOCITY_Y,0) = 0.000000; -NODES[158](VELOCITY_Z,0) = 0.000000; -NODES[159](VELOCITY_X,0) = 0.000000; -NODES[159](VELOCITY_Y,0) = 0.000000; -NODES[159](VELOCITY_Z,0) = 0.000000; -NODES[160](VELOCITY_X,0) = 0.000000; -NODES[160](VELOCITY_Y,0) = 0.000000; -NODES[160](VELOCITY_Z,0) = 0.000000; -NODES[161](VELOCITY_X,0) = 0.000000; -NODES[161](VELOCITY_Y,0) = 0.000000; -NODES[161](VELOCITY_Z,0) = 0.000000; -NODES[162](VELOCITY_X,0) = 0.000000; -NODES[162](VELOCITY_Y,0) = 0.000000; -NODES[162](VELOCITY_Z,0) = 0.000000; -NODES[163](VELOCITY_X,0) = 0.000000; -NODES[163](VELOCITY_Y,0) = 0.000000; -NODES[163](VELOCITY_Z,0) = 0.000000; -NODES[164](VELOCITY_X,0) = 0.000000; -NODES[164](VELOCITY_Y,0) = 0.000000; -NODES[164](VELOCITY_Z,0) = 0.000000; -NODES[165](VELOCITY_X,0) = 0.000000; -NODES[165](VELOCITY_Y,0) = 0.000000; -NODES[165](VELOCITY_Z,0) = 0.000000; -NODES[166](VELOCITY_X,0) = 0.000000; -NODES[166](VELOCITY_Y,0) = 0.000000; -NODES[166](VELOCITY_Z,0) = 0.000000; -NODES[167](VELOCITY_X,0) = 0.000000; -NODES[167](VELOCITY_Y,0) = 0.000000; -NODES[167](VELOCITY_Z,0) = 0.000000; -NODES[181](VELOCITY_X,0) = 0.000000; -NODES[181](VELOCITY_Y,0) = 0.000000; -NODES[181](VELOCITY_Z,0) = 0.000000; -NODES[183](VELOCITY_X,0) = 0.000000; -NODES[183](VELOCITY_Y,0) = 0.000000; -NODES[183](VELOCITY_Z,0) = 0.000000; -NODES[202](VELOCITY_X,0) = 0.000000; -NODES[202](VELOCITY_Y,0) = 0.000000; -NODES[202](VELOCITY_Z,0) = 0.000000; -NODES[204](VELOCITY_X,0) = 0.000000; -NODES[204](VELOCITY_Y,0) = 0.000000; -NODES[204](VELOCITY_Z,0) = 0.000000; -NODES[228](VELOCITY_X,0) = 0.000000; -NODES[228](VELOCITY_Y,0) = 0.000000; -NODES[228](VELOCITY_Z,0) = 0.000000; -NODES[231](VELOCITY_X,0) = 0.000000; -NODES[231](VELOCITY_Y,0) = 0.000000; -NODES[231](VELOCITY_Z,0) = 0.000000; -NODES[257](VELOCITY_X,0) = 0.000000; -NODES[257](VELOCITY_Y,0) = 0.000000; -NODES[257](VELOCITY_Z,0) = 0.000000; -NODES[261](VELOCITY_X,0) = 0.000000; -NODES[261](VELOCITY_Y,0) = 0.000000; -NODES[261](VELOCITY_Z,0) = 0.000000; -NODES[291](VELOCITY_X,0) = 0.000000; -NODES[291](VELOCITY_Y,0) = 0.000000; -NODES[291](VELOCITY_Z,0) = 0.000000; -NODES[299](VELOCITY_X,0) = 0.000000; -NODES[299](VELOCITY_Y,0) = 0.000000; -NODES[299](VELOCITY_Z,0) = 0.000000; -NODES[329](VELOCITY_X,0) = 0.000000; -NODES[329](VELOCITY_Y,0) = 0.000000; -NODES[329](VELOCITY_Z,0) = 0.000000; -NODES[337](VELOCITY_X,0) = 0.000000; -NODES[337](VELOCITY_Y,0) = 0.000000; -NODES[337](VELOCITY_Z,0) = 0.000000; -NODES[371](VELOCITY_X,0) = 0.000000; -NODES[371](VELOCITY_Y,0) = 0.000000; -NODES[371](VELOCITY_Z,0) = 0.000000; -NODES[381](VELOCITY_X,0) = 0.000000; -NODES[381](VELOCITY_Y,0) = 0.000000; -NODES[381](VELOCITY_Z,0) = 0.000000; -NODES[414](VELOCITY_X,0) = 0.000000; -NODES[414](VELOCITY_Y,0) = 0.000000; -NODES[414](VELOCITY_Z,0) = 0.000000; -NODES[425](VELOCITY_X,0) = 0.000000; -NODES[425](VELOCITY_Y,0) = 0.000000; -NODES[425](VELOCITY_Z,0) = 0.000000; -NODES[462](VELOCITY_X,0) = 0.000000; -NODES[462](VELOCITY_Y,0) = 0.000000; -NODES[462](VELOCITY_Z,0) = 0.000000; -NODES[470](VELOCITY_X,0) = 0.000000; -NODES[470](VELOCITY_Y,0) = 0.000000; -NODES[470](VELOCITY_Z,0) = 0.000000; -NODES[505](VELOCITY_X,0) = 0.000000; -NODES[505](VELOCITY_Y,0) = 0.000000; -NODES[505](VELOCITY_Z,0) = 0.000000; -NODES[518](VELOCITY_X,0) = 0.000000; -NODES[518](VELOCITY_Y,0) = 0.000000; -NODES[518](VELOCITY_Z,0) = 0.000000; -NODES[557](VELOCITY_X,0) = 0.000000; -NODES[557](VELOCITY_Y,0) = 0.000000; -NODES[557](VELOCITY_Z,0) = 0.000000; -NODES[570](VELOCITY_X,0) = 0.000000; -NODES[570](VELOCITY_Y,0) = 0.000000; -NODES[570](VELOCITY_Z,0) = 0.000000; -NODES[607](VELOCITY_X,0) = 0.000000; -NODES[607](VELOCITY_Y,0) = 0.000000; -NODES[607](VELOCITY_Z,0) = 0.000000; -NODES[622](VELOCITY_X,0) = 0.000000; -NODES[622](VELOCITY_Y,0) = 0.000000; -NODES[622](VELOCITY_Z,0) = 0.000000; -NODES[663](VELOCITY_X,0) = 0.000000; -NODES[663](VELOCITY_Y,0) = 0.000000; -NODES[663](VELOCITY_Z,0) = 0.000000; -NODES[677](VELOCITY_X,0) = 0.000000; -NODES[677](VELOCITY_Y,0) = 0.000000; -NODES[677](VELOCITY_Z,0) = 0.000000; -NODES[721](VELOCITY_X,0) = 0.000000; -NODES[721](VELOCITY_Y,0) = 0.000000; -NODES[721](VELOCITY_Z,0) = 0.000000; -NODES[738](VELOCITY_X,0) = 0.000000; -NODES[738](VELOCITY_Y,0) = 0.000000; -NODES[738](VELOCITY_Z,0) = 0.000000; -NODES[781](VELOCITY_X,0) = 0.000000; -NODES[781](VELOCITY_Y,0) = 0.000000; -NODES[781](VELOCITY_Z,0) = 0.000000; -NODES[802](VELOCITY_X,0) = 0.000000; -NODES[802](VELOCITY_Y,0) = 0.000000; -NODES[802](VELOCITY_Z,0) = 0.000000; -NODES[845](VELOCITY_X,0) = 0.000000; -NODES[845](VELOCITY_Y,0) = 0.000000; -NODES[845](VELOCITY_Z,0) = 0.000000; -NODES[867](VELOCITY_X,0) = 0.000000; -NODES[867](VELOCITY_Y,0) = 0.000000; -NODES[867](VELOCITY_Z,0) = 0.000000; -NODES[912](VELOCITY_X,0) = 0.000000; -NODES[912](VELOCITY_Y,0) = 0.000000; -NODES[912](VELOCITY_Z,0) = 0.000000; -NODES[938](VELOCITY_X,0) = 0.000000; -NODES[938](VELOCITY_Y,0) = 0.000000; -NODES[938](VELOCITY_Z,0) = 0.000000; -NODES[983](VELOCITY_X,0) = 0.000000; -NODES[983](VELOCITY_Y,0) = 0.000000; -NODES[983](VELOCITY_Z,0) = 0.000000; -NODES[1009](VELOCITY_X,0) = 0.000000; -NODES[1009](VELOCITY_Y,0) = 0.000000; -NODES[1009](VELOCITY_Z,0) = 0.000000; -NODES[1048](VELOCITY_X,0) = 0.000000; -NODES[1048](VELOCITY_Y,0) = 0.000000; -NODES[1048](VELOCITY_Z,0) = 0.000000; -NODES[1049](VELOCITY_X,0) = 0.000000; -NODES[1049](VELOCITY_Y,0) = 0.000000; -NODES[1049](VELOCITY_Z,0) = 0.000000; -NODES[1051](VELOCITY_X,0) = 0.000000; -NODES[1051](VELOCITY_Y,0) = 0.000000; -NODES[1051](VELOCITY_Z,0) = 0.000000; -NODES[1054](VELOCITY_X,0) = 0.000000; -NODES[1054](VELOCITY_Y,0) = 0.000000; -NODES[1054](VELOCITY_Z,0) = 0.000000; -NODES[1057](VELOCITY_X,0) = 0.000000; -NODES[1057](VELOCITY_Y,0) = 0.000000; -NODES[1057](VELOCITY_Z,0) = 0.000000; -NODES[1061](VELOCITY_X,0) = 0.000000; -NODES[1061](VELOCITY_Y,0) = 0.000000; -NODES[1061](VELOCITY_Z,0) = 0.000000; -NODES[1062](VELOCITY_X,0) = 0.000000; -NODES[1062](VELOCITY_Y,0) = 0.000000; -NODES[1062](VELOCITY_Z,0) = 0.000000; -NODES[1068](VELOCITY_X,0) = 0.000000; -NODES[1068](VELOCITY_Y,0) = 0.000000; -NODES[1068](VELOCITY_Z,0) = 0.000000; -NODES[1070](VELOCITY_X,0) = 0.000000; -NODES[1070](VELOCITY_Y,0) = 0.000000; -NODES[1070](VELOCITY_Z,0) = 0.000000; -NODES[1079](VELOCITY_X,0) = 0.000000; -NODES[1079](VELOCITY_Y,0) = 0.000000; -NODES[1079](VELOCITY_Z,0) = 0.000000; -NODES[1080](VELOCITY_X,0) = 0.000000; -NODES[1080](VELOCITY_Y,0) = 0.000000; -NODES[1080](VELOCITY_Z,0) = 0.000000; -NODES[1086](VELOCITY_X,0) = 0.000000; -NODES[1086](VELOCITY_Y,0) = 0.000000; -NODES[1086](VELOCITY_Z,0) = 0.000000; -NODES[1095](VELOCITY_X,0) = 0.000000; -NODES[1095](VELOCITY_Y,0) = 0.000000; -NODES[1095](VELOCITY_Z,0) = 0.000000; -NODES[1101](VELOCITY_X,0) = 0.000000; -NODES[1101](VELOCITY_Y,0) = 0.000000; -NODES[1101](VELOCITY_Z,0) = 0.000000; -NODES[1105](VELOCITY_X,0) = 0.000000; -NODES[1105](VELOCITY_Y,0) = 0.000000; -NODES[1105](VELOCITY_Z,0) = 0.000000; -NODES[1115](VELOCITY_X,0) = 0.000000; -NODES[1115](VELOCITY_Y,0) = 0.000000; -NODES[1115](VELOCITY_Z,0) = 0.000000; -NODES[1126](VELOCITY_X,0) = 0.000000; -NODES[1126](VELOCITY_Y,0) = 0.000000; -NODES[1126](VELOCITY_Z,0) = 0.000000; -NODES[1132](VELOCITY_X,0) = 0.000000; -NODES[1132](VELOCITY_Y,0) = 0.000000; -NODES[1132](VELOCITY_Z,0) = 0.000000; -NODES[1140](VELOCITY_X,0) = 0.000000; -NODES[1140](VELOCITY_Y,0) = 0.000000; -NODES[1140](VELOCITY_Z,0) = 0.000000; -NODES[1143](VELOCITY_X,0) = 0.000000; -NODES[1143](VELOCITY_Y,0) = 0.000000; -NODES[1143](VELOCITY_Z,0) = 0.000000; -NODES[1152](VELOCITY_X,0) = 0.000000; -NODES[1152](VELOCITY_Y,0) = 0.000000; -NODES[1152](VELOCITY_Z,0) = 0.000000; -NODES[1162](VELOCITY_X,0) = 0.000000; -NODES[1162](VELOCITY_Y,0) = 0.000000; -NODES[1162](VELOCITY_Z,0) = 0.000000; -NODES[1173](VELOCITY_X,0) = 0.000000; -NODES[1173](VELOCITY_Y,0) = 0.000000; -NODES[1173](VELOCITY_Z,0) = 0.000000; -NODES[1184](VELOCITY_X,0) = 0.000000; -NODES[1184](VELOCITY_Y,0) = 0.000000; -NODES[1184](VELOCITY_Z,0) = 0.000000; -NODES[1194](VELOCITY_X,0) = 0.000000; -NODES[1194](VELOCITY_Y,0) = 0.000000; -NODES[1194](VELOCITY_Z,0) = 0.000000; -NODES[1200](VELOCITY_X,0) = 0.000000; -NODES[1200](VELOCITY_Y,0) = 0.000000; -NODES[1200](VELOCITY_Z,0) = 0.000000; -NODES[1207](VELOCITY_X,0) = 0.000000; -NODES[1207](VELOCITY_Y,0) = 0.000000; -NODES[1207](VELOCITY_Z,0) = 0.000000; -NODES[1218](VELOCITY_X,0) = 0.000000; -NODES[1218](VELOCITY_Y,0) = 0.000000; -NODES[1218](VELOCITY_Z,0) = 0.000000; -NODES[1233](VELOCITY_X,0) = 0.000000; -NODES[1233](VELOCITY_Y,0) = 0.000000; -NODES[1233](VELOCITY_Z,0) = 0.000000; -NODES[1244](VELOCITY_X,0) = 0.000000; -NODES[1244](VELOCITY_Y,0) = 0.000000; -NODES[1244](VELOCITY_Z,0) = 0.000000; -NODES[1252](VELOCITY_X,0) = 0.000000; -NODES[1252](VELOCITY_Y,0) = 0.000000; -NODES[1252](VELOCITY_Z,0) = 0.000000; -NODES[1258](VELOCITY_X,0) = 0.000000; -NODES[1258](VELOCITY_Y,0) = 0.000000; -NODES[1258](VELOCITY_Z,0) = 0.000000; -NODES[1269](VELOCITY_X,0) = 0.000000; -NODES[1269](VELOCITY_Y,0) = 0.000000; -NODES[1269](VELOCITY_Z,0) = 0.000000; -NODES[1287](VELOCITY_X,0) = 0.000000; -NODES[1287](VELOCITY_Y,0) = 0.000000; -NODES[1287](VELOCITY_Z,0) = 0.000000; -NODES[1296](VELOCITY_X,0) = 0.000000; -NODES[1296](VELOCITY_Y,0) = 0.000000; -NODES[1296](VELOCITY_Z,0) = 0.000000; -NODES[1301](VELOCITY_X,0) = 0.000000; -NODES[1301](VELOCITY_Y,0) = 0.000000; -NODES[1301](VELOCITY_Z,0) = 0.000000; -NODES[1314](VELOCITY_X,0) = 0.000000; -NODES[1314](VELOCITY_Y,0) = 0.000000; -NODES[1314](VELOCITY_Z,0) = 0.000000; -NODES[1327](VELOCITY_X,0) = 0.000000; -NODES[1327](VELOCITY_Y,0) = 0.000000; -NODES[1327](VELOCITY_Z,0) = 0.000000; -NODES[1342](VELOCITY_X,0) = 0.000000; -NODES[1342](VELOCITY_Y,0) = 0.000000; -NODES[1342](VELOCITY_Z,0) = 0.000000; -NODES[1349](VELOCITY_X,0) = 0.000000; -NODES[1349](VELOCITY_Y,0) = 0.000000; -NODES[1349](VELOCITY_Z,0) = 0.000000; -NODES[1356](VELOCITY_X,0) = 0.000000; -NODES[1356](VELOCITY_Y,0) = 0.000000; -NODES[1356](VELOCITY_Z,0) = 0.000000; -NODES[1370](VELOCITY_X,0) = 0.000000; -NODES[1370](VELOCITY_Y,0) = 0.000000; -NODES[1370](VELOCITY_Z,0) = 0.000000; -NODES[1386](VELOCITY_X,0) = 0.000000; -NODES[1386](VELOCITY_Y,0) = 0.000000; -NODES[1386](VELOCITY_Z,0) = 0.000000; -NODES[1396](VELOCITY_X,0) = 0.000000; -NODES[1396](VELOCITY_Y,0) = 0.000000; -NODES[1396](VELOCITY_Z,0) = 0.000000; -NODES[1403](VELOCITY_X,0) = 0.000000; -NODES[1403](VELOCITY_Y,0) = 0.000000; -NODES[1403](VELOCITY_Z,0) = 0.000000; -NODES[1416](VELOCITY_X,0) = 0.000000; -NODES[1416](VELOCITY_Y,0) = 0.000000; -NODES[1416](VELOCITY_Z,0) = 0.000000; -NODES[1434](VELOCITY_X,0) = 0.000000; -NODES[1434](VELOCITY_Y,0) = 0.000000; -NODES[1434](VELOCITY_Z,0) = 0.000000; -NODES[1441](VELOCITY_X,0) = 0.000000; -NODES[1441](VELOCITY_Y,0) = 0.000000; -NODES[1441](VELOCITY_Z,0) = 0.000000; -NODES[1452](VELOCITY_X,0) = 0.000000; -NODES[1452](VELOCITY_Y,0) = 0.000000; -NODES[1452](VELOCITY_Z,0) = 0.000000; -NODES[1467](VELOCITY_X,0) = 0.000000; -NODES[1467](VELOCITY_Y,0) = 0.000000; -NODES[1467](VELOCITY_Z,0) = 0.000000; -NODES[1480](VELOCITY_X,0) = 0.000000; -NODES[1480](VELOCITY_Y,0) = 0.000000; -NODES[1480](VELOCITY_Z,0) = 0.000000; -NODES[1485](VELOCITY_X,0) = 0.000000; -NODES[1485](VELOCITY_Y,0) = 0.000000; -NODES[1485](VELOCITY_Z,0) = 0.000000; -NODES[1500](VELOCITY_X,0) = 0.000000; -NODES[1500](VELOCITY_Y,0) = 0.000000; -NODES[1500](VELOCITY_Z,0) = 0.000000; -NODES[1517](VELOCITY_X,0) = 0.000000; -NODES[1517](VELOCITY_Y,0) = 0.000000; -NODES[1517](VELOCITY_Z,0) = 0.000000; -NODES[1527](VELOCITY_X,0) = 0.000000; -NODES[1527](VELOCITY_Y,0) = 0.000000; -NODES[1527](VELOCITY_Z,0) = 0.000000; -NODES[1534](VELOCITY_X,0) = 0.000000; -NODES[1534](VELOCITY_Y,0) = 0.000000; -NODES[1534](VELOCITY_Z,0) = 0.000000; -NODES[1550](VELOCITY_X,0) = 0.000000; -NODES[1550](VELOCITY_Y,0) = 0.000000; -NODES[1550](VELOCITY_Z,0) = 0.000000; -NODES[1566](VELOCITY_X,0) = 0.000000; -NODES[1566](VELOCITY_Y,0) = 0.000000; -NODES[1566](VELOCITY_Z,0) = 0.000000; -NODES[1571](VELOCITY_X,0) = 0.000000; -NODES[1571](VELOCITY_Y,0) = 0.000000; -NODES[1571](VELOCITY_Z,0) = 0.000000; -NODES[1584](VELOCITY_X,0) = 0.000000; -NODES[1584](VELOCITY_Y,0) = 0.000000; -NODES[1584](VELOCITY_Z,0) = 0.000000; -NODES[1602](VELOCITY_X,0) = 0.000000; -NODES[1602](VELOCITY_Y,0) = 0.000000; -NODES[1602](VELOCITY_Z,0) = 0.000000; -NODES[1611](VELOCITY_X,0) = 0.000000; -NODES[1611](VELOCITY_Y,0) = 0.000000; -NODES[1611](VELOCITY_Z,0) = 0.000000; -NODES[1622](VELOCITY_X,0) = 0.000000; -NODES[1622](VELOCITY_Y,0) = 0.000000; -NODES[1622](VELOCITY_Z,0) = 0.000000; -NODES[1639](VELOCITY_X,0) = 0.000000; -NODES[1639](VELOCITY_Y,0) = 0.000000; -NODES[1639](VELOCITY_Z,0) = 0.000000; -NODES[1651](VELOCITY_X,0) = 0.000000; -NODES[1651](VELOCITY_Y,0) = 0.000000; -NODES[1651](VELOCITY_Z,0) = 0.000000; -NODES[1656](VELOCITY_X,0) = 0.000000; -NODES[1656](VELOCITY_Y,0) = 0.000000; -NODES[1656](VELOCITY_Z,0) = 0.000000; -NODES[1677](VELOCITY_X,0) = 0.000000; -NODES[1677](VELOCITY_Y,0) = 0.000000; -NODES[1677](VELOCITY_Z,0) = 0.000000; -NODES[1690](VELOCITY_X,0) = 0.000000; -NODES[1690](VELOCITY_Y,0) = 0.000000; -NODES[1690](VELOCITY_Z,0) = 0.000000; -NODES[1693](VELOCITY_X,0) = 0.000000; -NODES[1693](VELOCITY_Y,0) = 0.000000; -NODES[1693](VELOCITY_Z,0) = 0.000000; -NODES[1712](VELOCITY_X,0) = 0.000000; -NODES[1712](VELOCITY_Y,0) = 0.000000; -NODES[1712](VELOCITY_Z,0) = 0.000000; -NODES[1729](VELOCITY_X,0) = 0.000000; -NODES[1729](VELOCITY_Y,0) = 0.000000; -NODES[1729](VELOCITY_Z,0) = 0.000000; -NODES[1730](VELOCITY_X,0) = 0.000000; -NODES[1730](VELOCITY_Y,0) = 0.000000; -NODES[1730](VELOCITY_Z,0) = 0.000000; -NODES[1747](VELOCITY_X,0) = 0.000000; -NODES[1747](VELOCITY_Y,0) = 0.000000; -NODES[1747](VELOCITY_Z,0) = 0.000000; -NODES[1765](VELOCITY_X,0) = 0.000000; -NODES[1765](VELOCITY_Y,0) = 0.000000; -NODES[1765](VELOCITY_Z,0) = 0.000000; -NODES[1767](VELOCITY_X,0) = 0.000000; -NODES[1767](VELOCITY_Y,0) = 0.000000; -NODES[1767](VELOCITY_Z,0) = 0.000000; -NODES[1784](VELOCITY_X,0) = 0.000000; -NODES[1784](VELOCITY_Y,0) = 0.000000; -NODES[1784](VELOCITY_Z,0) = 0.000000; -NODES[1803](VELOCITY_X,0) = 0.000000; -NODES[1803](VELOCITY_Y,0) = 0.000000; -NODES[1803](VELOCITY_Z,0) = 0.000000; -NODES[1804](VELOCITY_X,0) = 0.000000; -NODES[1804](VELOCITY_Y,0) = 0.000000; -NODES[1804](VELOCITY_Z,0) = 0.000000; -NODES[1822](VELOCITY_X,0) = 0.000000; -NODES[1822](VELOCITY_Y,0) = 0.000000; -NODES[1822](VELOCITY_Z,0) = 0.000000; -NODES[1839](VELOCITY_X,0) = 0.000000; -NODES[1839](VELOCITY_Y,0) = 0.000000; -NODES[1839](VELOCITY_Z,0) = 0.000000; -NODES[1840](VELOCITY_X,0) = 0.000000; -NODES[1840](VELOCITY_Y,0) = 0.000000; -NODES[1840](VELOCITY_Z,0) = 0.000000; -NODES[1857](VELOCITY_X,0) = 0.000000; -NODES[1857](VELOCITY_Y,0) = 0.000000; -NODES[1857](VELOCITY_Z,0) = 0.000000; -NODES[1873](VELOCITY_X,0) = 0.000000; -NODES[1873](VELOCITY_Y,0) = 0.000000; -NODES[1873](VELOCITY_Z,0) = 0.000000; -NODES[1876](VELOCITY_X,0) = 0.000000; -NODES[1876](VELOCITY_Y,0) = 0.000000; -NODES[1876](VELOCITY_Z,0) = 0.000000; -NODES[1894](VELOCITY_X,0) = 0.000000; -NODES[1894](VELOCITY_Y,0) = 0.000000; -NODES[1894](VELOCITY_Z,0) = 0.000000; -NODES[1909](VELOCITY_X,0) = 0.000000; -NODES[1909](VELOCITY_Y,0) = 0.000000; -NODES[1909](VELOCITY_Z,0) = 0.000000; -NODES[1913](VELOCITY_X,0) = 0.000000; -NODES[1913](VELOCITY_Y,0) = 0.000000; -NODES[1913](VELOCITY_Z,0) = 0.000000; -NODES[1932](VELOCITY_X,0) = 0.000000; -NODES[1932](VELOCITY_Y,0) = 0.000000; -NODES[1932](VELOCITY_Z,0) = 0.000000; -NODES[1943](VELOCITY_X,0) = 0.000000; -NODES[1943](VELOCITY_Y,0) = 0.000000; -NODES[1943](VELOCITY_Z,0) = 0.000000; -NODES[1950](VELOCITY_X,0) = 0.000000; -NODES[1950](VELOCITY_Y,0) = 0.000000; -NODES[1950](VELOCITY_Z,0) = 0.000000; -NODES[1969](VELOCITY_X,0) = 0.000000; -NODES[1969](VELOCITY_Y,0) = 0.000000; -NODES[1969](VELOCITY_Z,0) = 0.000000; -NODES[1975](VELOCITY_X,0) = 0.000000; -NODES[1975](VELOCITY_Y,0) = 0.000000; -NODES[1975](VELOCITY_Z,0) = 0.000000; -NODES[1988](VELOCITY_X,0) = 0.000000; -NODES[1988](VELOCITY_Y,0) = 0.000000; -NODES[1988](VELOCITY_Z,0) = 0.000000; -NODES[2008](VELOCITY_X,0) = 0.000000; -NODES[2008](VELOCITY_Y,0) = 0.000000; -NODES[2008](VELOCITY_Z,0) = 0.000000; -NODES[2010](VELOCITY_X,0) = 0.000000; -NODES[2010](VELOCITY_Y,0) = 0.000000; -NODES[2010](VELOCITY_Z,0) = 0.000000; -NODES[2025](VELOCITY_X,0) = 0.000000; -NODES[2025](VELOCITY_Y,0) = 0.000000; -NODES[2025](VELOCITY_Z,0) = 0.000000; -NODES[2043](VELOCITY_X,0) = 0.000000; -NODES[2043](VELOCITY_Y,0) = 0.000000; -NODES[2043](VELOCITY_Z,0) = 0.000000; -NODES[2045](VELOCITY_X,0) = 0.000000; -NODES[2045](VELOCITY_Y,0) = 0.000000; -NODES[2045](VELOCITY_Z,0) = 0.000000; -NODES[2064](VELOCITY_X,0) = 0.000000; -NODES[2064](VELOCITY_Y,0) = 0.000000; -NODES[2064](VELOCITY_Z,0) = 0.000000; -NODES[2077](VELOCITY_X,0) = 0.000000; -NODES[2077](VELOCITY_Y,0) = 0.000000; -NODES[2077](VELOCITY_Z,0) = 0.000000; -NODES[2086](VELOCITY_X,0) = 0.000000; -NODES[2086](VELOCITY_Y,0) = 0.000000; -NODES[2086](VELOCITY_Z,0) = 0.000000; -NODES[2102](VELOCITY_X,0) = 0.000000; -NODES[2102](VELOCITY_Y,0) = 0.000000; -NODES[2102](VELOCITY_Z,0) = 0.000000; -NODES[2110](VELOCITY_X,0) = 0.000000; -NODES[2110](VELOCITY_Y,0) = 0.000000; -NODES[2110](VELOCITY_Z,0) = 0.000000; -NODES[2124](VELOCITY_X,0) = 0.000000; -NODES[2124](VELOCITY_Y,0) = 0.000000; -NODES[2124](VELOCITY_Z,0) = 0.000000; -NODES[2143](VELOCITY_X,0) = 0.000000; -NODES[2143](VELOCITY_Y,0) = 0.000000; -NODES[2143](VELOCITY_Z,0) = 0.000000; -NODES[2144](VELOCITY_X,0) = 0.000000; -NODES[2144](VELOCITY_Y,0) = 0.000000; -NODES[2144](VELOCITY_Z,0) = 0.000000; -NODES[2166](VELOCITY_X,0) = 0.000000; -NODES[2166](VELOCITY_Y,0) = 0.000000; -NODES[2166](VELOCITY_Z,0) = 0.000000; -NODES[2176](VELOCITY_X,0) = 0.000000; -NODES[2176](VELOCITY_Y,0) = 0.000000; -NODES[2176](VELOCITY_Z,0) = 0.000000; -NODES[2186](VELOCITY_X,0) = 0.000000; -NODES[2186](VELOCITY_Y,0) = 0.000000; -NODES[2186](VELOCITY_Z,0) = 0.000000; -NODES[2205](VELOCITY_X,0) = 0.000000; -NODES[2205](VELOCITY_Y,0) = 0.000000; -NODES[2205](VELOCITY_Z,0) = 0.000000; -NODES[2208](VELOCITY_X,0) = 0.000000; -NODES[2208](VELOCITY_Y,0) = 0.000000; -NODES[2208](VELOCITY_Z,0) = 0.000000; -NODES[2226](VELOCITY_X,0) = 0.000000; -NODES[2226](VELOCITY_Y,0) = 0.000000; -NODES[2226](VELOCITY_Z,0) = 0.000000; -NODES[2240](VELOCITY_X,0) = 0.000000; -NODES[2240](VELOCITY_Y,0) = 0.000000; -NODES[2240](VELOCITY_Z,0) = 0.000000; -NODES[2246](VELOCITY_X,0) = 0.000000; -NODES[2246](VELOCITY_Y,0) = 0.000000; -NODES[2246](VELOCITY_Z,0) = 0.000000; -NODES[2267](VELOCITY_X,0) = 0.000000; -NODES[2267](VELOCITY_Y,0) = 0.000000; -NODES[2267](VELOCITY_Z,0) = 0.000000; -NODES[2272](VELOCITY_X,0) = 0.000000; -NODES[2272](VELOCITY_Y,0) = 0.000000; -NODES[2272](VELOCITY_Z,0) = 0.000000; -NODES[2287](VELOCITY_X,0) = 0.000000; -NODES[2287](VELOCITY_Y,0) = 0.000000; -NODES[2287](VELOCITY_Z,0) = 0.000000; -NODES[2303](VELOCITY_X,0) = 0.000000; -NODES[2303](VELOCITY_Y,0) = 0.000000; -NODES[2303](VELOCITY_Z,0) = 0.000000; -NODES[2308](VELOCITY_X,0) = 0.000000; -NODES[2308](VELOCITY_Y,0) = 0.000000; -NODES[2308](VELOCITY_Z,0) = 0.000000; -NODES[2326](VELOCITY_X,0) = 0.000000; -NODES[2326](VELOCITY_Y,0) = 0.000000; -NODES[2326](VELOCITY_Z,0) = 0.000000; -NODES[2336](VELOCITY_X,0) = 0.000000; -NODES[2336](VELOCITY_Y,0) = 0.000000; -NODES[2336](VELOCITY_Z,0) = 0.000000; -NODES[2349](VELOCITY_X,0) = 0.000000; -NODES[2349](VELOCITY_Y,0) = 0.000000; -NODES[2349](VELOCITY_Z,0) = 0.000000; -NODES[2367](VELOCITY_X,0) = 0.000000; -NODES[2367](VELOCITY_Y,0) = 0.000000; -NODES[2367](VELOCITY_Z,0) = 0.000000; -NODES[2369](VELOCITY_X,0) = 0.000000; -NODES[2369](VELOCITY_Y,0) = 0.000000; -NODES[2369](VELOCITY_Z,0) = 0.000000; -NODES[2389](VELOCITY_X,0) = 0.000000; -NODES[2389](VELOCITY_Y,0) = 0.000000; -NODES[2389](VELOCITY_Z,0) = 0.000000; -NODES[2397](VELOCITY_X,0) = 0.000000; -NODES[2397](VELOCITY_Y,0) = 0.000000; -NODES[2397](VELOCITY_Z,0) = 0.000000; -NODES[2411](VELOCITY_X,0) = 0.000000; -NODES[2411](VELOCITY_Y,0) = 0.000000; -NODES[2411](VELOCITY_Z,0) = 0.000000; -NODES[2428](VELOCITY_X,0) = 0.000000; -NODES[2428](VELOCITY_Y,0) = 0.000000; -NODES[2428](VELOCITY_Z,0) = 0.000000; -NODES[2433](VELOCITY_X,0) = 0.000000; -NODES[2433](VELOCITY_Y,0) = 0.000000; -NODES[2433](VELOCITY_Z,0) = 0.000000; -NODES[2451](VELOCITY_X,0) = 0.000000; -NODES[2451](VELOCITY_Y,0) = 0.000000; -NODES[2451](VELOCITY_Z,0) = 0.000000; -NODES[2462](VELOCITY_X,0) = 0.000000; -NODES[2462](VELOCITY_Y,0) = 0.000000; -NODES[2462](VELOCITY_Z,0) = 0.000000; -NODES[2472](VELOCITY_X,0) = 0.000000; -NODES[2472](VELOCITY_Y,0) = 0.000000; -NODES[2472](VELOCITY_Z,0) = 0.000000; -NODES[2492](VELOCITY_X,0) = 0.000000; -NODES[2492](VELOCITY_Y,0) = 0.000000; -NODES[2492](VELOCITY_Z,0) = 0.000000; -NODES[2494](VELOCITY_X,0) = 0.000000; -NODES[2494](VELOCITY_Y,0) = 0.000000; -NODES[2494](VELOCITY_Z,0) = 0.000000; -NODES[2515](VELOCITY_X,0) = 0.000000; -NODES[2515](VELOCITY_Y,0) = 0.000000; -NODES[2515](VELOCITY_Z,0) = 0.000000; -NODES[2522](VELOCITY_X,0) = 0.000000; -NODES[2522](VELOCITY_Y,0) = 0.000000; -NODES[2522](VELOCITY_Z,0) = 0.000000; -NODES[2537](VELOCITY_X,0) = 0.000000; -NODES[2537](VELOCITY_Y,0) = 0.000000; -NODES[2537](VELOCITY_Z,0) = 0.000000; -NODES[2551](VELOCITY_X,0) = 0.000000; -NODES[2551](VELOCITY_Y,0) = 0.000000; -NODES[2551](VELOCITY_Z,0) = 0.000000; -NODES[2557](VELOCITY_X,0) = 0.000000; -NODES[2557](VELOCITY_Y,0) = 0.000000; -NODES[2557](VELOCITY_Z,0) = 0.000000; -NODES[2578](VELOCITY_X,0) = 0.000000; -NODES[2578](VELOCITY_Y,0) = 0.000000; -NODES[2578](VELOCITY_Z,0) = 0.000000; -NODES[2582](VELOCITY_X,0) = 0.000000; -NODES[2582](VELOCITY_Y,0) = 0.000000; -NODES[2582](VELOCITY_Z,0) = 0.000000; -NODES[2598](VELOCITY_X,0) = 0.000000; -NODES[2598](VELOCITY_Y,0) = 0.000000; -NODES[2598](VELOCITY_Z,0) = 0.000000; -NODES[2612](VELOCITY_X,0) = 0.000000; -NODES[2612](VELOCITY_Y,0) = 0.000000; -NODES[2612](VELOCITY_Z,0) = 0.000000; -NODES[2620](VELOCITY_X,0) = 0.000000; -NODES[2620](VELOCITY_Y,0) = 0.000000; -NODES[2620](VELOCITY_Z,0) = 0.000000; -NODES[2640](VELOCITY_X,0) = 0.000000; -NODES[2640](VELOCITY_Y,0) = 0.000000; -NODES[2640](VELOCITY_Z,0) = 0.000000; -NODES[2642](VELOCITY_X,0) = 0.000000; -NODES[2642](VELOCITY_Y,0) = 0.000000; -NODES[2642](VELOCITY_Z,0) = 0.000000; -NODES[2662](VELOCITY_X,0) = 0.000000; -NODES[2662](VELOCITY_Y,0) = 0.000000; -NODES[2662](VELOCITY_Z,0) = 0.000000; -NODES[2671](VELOCITY_X,0) = 0.000000; -NODES[2671](VELOCITY_Y,0) = 0.000000; -NODES[2671](VELOCITY_Z,0) = 0.000000; -NODES[2684](VELOCITY_X,0) = 0.000000; -NODES[2684](VELOCITY_Y,0) = 0.000000; -NODES[2684](VELOCITY_Z,0) = 0.000000; -NODES[2702](VELOCITY_X,0) = 0.000000; -NODES[2702](VELOCITY_Y,0) = 0.000000; -NODES[2702](VELOCITY_Z,0) = 0.000000; -NODES[2705](VELOCITY_X,0) = 0.000000; -NODES[2705](VELOCITY_Y,0) = 0.000000; -NODES[2705](VELOCITY_Z,0) = 0.000000; -NODES[2725](VELOCITY_X,0) = 0.000000; -NODES[2725](VELOCITY_Y,0) = 0.000000; -NODES[2725](VELOCITY_Z,0) = 0.000000; -NODES[2731](VELOCITY_X,0) = 0.000000; -NODES[2731](VELOCITY_Y,0) = 0.000000; -NODES[2731](VELOCITY_Z,0) = 0.000000; -NODES[2746](VELOCITY_X,0) = 0.000000; -NODES[2746](VELOCITY_Y,0) = 0.000000; -NODES[2746](VELOCITY_Z,0) = 0.000000; -NODES[2760](VELOCITY_X,0) = 0.000000; -NODES[2760](VELOCITY_Y,0) = 0.000000; -NODES[2760](VELOCITY_Z,0) = 0.000000; -NODES[2767](VELOCITY_X,0) = 0.000000; -NODES[2767](VELOCITY_Y,0) = 0.000000; -NODES[2767](VELOCITY_Z,0) = 0.000000; -NODES[2788](VELOCITY_X,0) = 0.000000; -NODES[2788](VELOCITY_Y,0) = 0.000000; -NODES[2788](VELOCITY_Z,0) = 0.000000; -NODES[2789](VELOCITY_X,0) = 0.000000; -NODES[2789](VELOCITY_Y,0) = 0.000000; -NODES[2789](VELOCITY_Z,0) = 0.000000; -NODES[2811](VELOCITY_X,0) = 0.000000; -NODES[2811](VELOCITY_Y,0) = 0.000000; -NODES[2811](VELOCITY_Z,0) = 0.000000; -NODES[2817](VELOCITY_X,0) = 0.000000; -NODES[2817](VELOCITY_Y,0) = 0.000000; -NODES[2817](VELOCITY_Z,0) = 0.000000; -NODES[2832](VELOCITY_X,0) = 0.000000; -NODES[2832](VELOCITY_Y,0) = 0.000000; -NODES[2832](VELOCITY_Z,0) = 0.000000; -NODES[2848](VELOCITY_X,0) = 0.000000; -NODES[2848](VELOCITY_Y,0) = 0.000000; -NODES[2848](VELOCITY_Z,0) = 0.000000; -NODES[2855](VELOCITY_X,0) = 0.000000; -NODES[2855](VELOCITY_Y,0) = 0.000000; -NODES[2855](VELOCITY_Z,0) = 0.000000; -NODES[2876](VELOCITY_X,0) = 0.000000; -NODES[2876](VELOCITY_Y,0) = 0.000000; -NODES[2876](VELOCITY_Z,0) = 0.000000; -NODES[2878](VELOCITY_X,0) = 0.000000; -NODES[2878](VELOCITY_Y,0) = 0.000000; -NODES[2878](VELOCITY_Z,0) = 0.000000; -NODES[2896](VELOCITY_X,0) = 0.000000; -NODES[2896](VELOCITY_Y,0) = 0.000000; -NODES[2896](VELOCITY_Z,0) = 0.000000; -NODES[2905](VELOCITY_X,0) = 0.000000; -NODES[2905](VELOCITY_Y,0) = 0.000000; -NODES[2905](VELOCITY_Z,0) = 0.000000; -NODES[2918](VELOCITY_X,0) = 0.000000; -NODES[2918](VELOCITY_Y,0) = 0.000000; -NODES[2918](VELOCITY_Z,0) = 0.000000; -NODES[2932](VELOCITY_X,0) = 0.000000; -NODES[2932](VELOCITY_Y,0) = 0.000000; -NODES[2932](VELOCITY_Z,0) = 0.000000; -NODES[2939](VELOCITY_X,0) = 0.000000; -NODES[2939](VELOCITY_Y,0) = 0.000000; -NODES[2939](VELOCITY_Z,0) = 0.000000; -NODES[2959](VELOCITY_X,0) = 0.000000; -NODES[2959](VELOCITY_Y,0) = 0.000000; -NODES[2959](VELOCITY_Z,0) = 0.000000; -NODES[2962](VELOCITY_X,0) = 0.000000; -NODES[2962](VELOCITY_Y,0) = 0.000000; -NODES[2962](VELOCITY_Z,0) = 0.000000; -NODES[2981](VELOCITY_X,0) = 0.000000; -NODES[2981](VELOCITY_Y,0) = 0.000000; -NODES[2981](VELOCITY_Z,0) = 0.000000; -NODES[2991](VELOCITY_X,0) = 0.000000; -NODES[2991](VELOCITY_Y,0) = 0.000000; -NODES[2991](VELOCITY_Z,0) = 0.000000; -NODES[3004](VELOCITY_X,0) = 0.000000; -NODES[3004](VELOCITY_Y,0) = 0.000000; -NODES[3004](VELOCITY_Z,0) = 0.000000; -NODES[3020](VELOCITY_X,0) = 0.000000; -NODES[3020](VELOCITY_Y,0) = 0.000000; -NODES[3020](VELOCITY_Z,0) = 0.000000; -NODES[3026](VELOCITY_X,0) = 0.000000; -NODES[3026](VELOCITY_Y,0) = 0.000000; -NODES[3026](VELOCITY_Z,0) = 0.000000; -NODES[3048](VELOCITY_X,0) = 0.000000; -NODES[3048](VELOCITY_Y,0) = 0.000000; -NODES[3048](VELOCITY_Z,0) = 0.000000; -NODES[3049](VELOCITY_X,0) = 0.000000; -NODES[3049](VELOCITY_Y,0) = 0.000000; -NODES[3049](VELOCITY_Z,0) = 0.000000; -NODES[3069](VELOCITY_X,0) = 0.000000; -NODES[3069](VELOCITY_Y,0) = 0.000000; -NODES[3069](VELOCITY_Z,0) = 0.000000; -NODES[3075](VELOCITY_X,0) = 0.000000; -NODES[3075](VELOCITY_Y,0) = 0.000000; -NODES[3075](VELOCITY_Z,0) = 0.000000; -NODES[3091](VELOCITY_X,0) = 0.000000; -NODES[3091](VELOCITY_Y,0) = 0.000000; -NODES[3091](VELOCITY_Z,0) = 0.000000; -NODES[3102](VELOCITY_X,0) = 0.000000; -NODES[3102](VELOCITY_Y,0) = 0.000000; -NODES[3102](VELOCITY_Z,0) = 0.000000; -NODES[3114](VELOCITY_X,0) = 0.000000; -NODES[3114](VELOCITY_Y,0) = 0.000000; -NODES[3114](VELOCITY_Z,0) = 0.000000; -NODES[3131](VELOCITY_X,0) = 0.000000; -NODES[3131](VELOCITY_Y,0) = 0.000000; -NODES[3131](VELOCITY_Z,0) = 0.000000; -NODES[3136](VELOCITY_X,0) = 0.000000; -NODES[3136](VELOCITY_Y,0) = 0.000000; -NODES[3136](VELOCITY_Z,0) = 0.000000; -NODES[3156](VELOCITY_X,0) = 0.000000; -NODES[3156](VELOCITY_Y,0) = 0.000000; -NODES[3156](VELOCITY_Z,0) = 0.000000; -NODES[3161](VELOCITY_X,0) = 0.000000; -NODES[3161](VELOCITY_Y,0) = 0.000000; -NODES[3161](VELOCITY_Z,0) = 0.000000; -NODES[3174](VELOCITY_X,0) = 0.000000; -NODES[3174](VELOCITY_Y,0) = 0.000000; -NODES[3174](VELOCITY_Z,0) = 0.000000; -NODES[3188](VELOCITY_X,0) = 0.000000; -NODES[3188](VELOCITY_Y,0) = 0.000000; -NODES[3188](VELOCITY_Z,0) = 0.000000; -NODES[3196](VELOCITY_X,0) = 0.000000; -NODES[3196](VELOCITY_Y,0) = 0.000000; -NODES[3196](VELOCITY_Z,0) = 0.000000; -NODES[3215](VELOCITY_X,0) = 0.000000; -NODES[3215](VELOCITY_Y,0) = 0.000000; -NODES[3215](VELOCITY_Z,0) = 0.000000; -NODES[3219](VELOCITY_X,0) = 0.000000; -NODES[3219](VELOCITY_Y,0) = 0.000000; -NODES[3219](VELOCITY_Z,0) = 0.000000; -NODES[3241](VELOCITY_X,0) = 0.000000; -NODES[3241](VELOCITY_Y,0) = 0.000000; -NODES[3241](VELOCITY_Z,0) = 0.000000; -NODES[3242](VELOCITY_X,0) = 0.000000; -NODES[3242](VELOCITY_Y,0) = 0.000000; -NODES[3242](VELOCITY_Z,0) = 0.000000; -NODES[3263](VELOCITY_X,0) = 0.000000; -NODES[3263](VELOCITY_Y,0) = 0.000000; -NODES[3263](VELOCITY_Z,0) = 0.000000; -NODES[3267](VELOCITY_X,0) = 0.000000; -NODES[3267](VELOCITY_Y,0) = 0.000000; -NODES[3267](VELOCITY_Z,0) = 0.000000; -NODES[3286](VELOCITY_X,0) = 0.000000; -NODES[3286](VELOCITY_Y,0) = 0.000000; -NODES[3286](VELOCITY_Z,0) = 0.000000; -NODES[3292](VELOCITY_X,0) = 0.000000; -NODES[3292](VELOCITY_Y,0) = 0.000000; -NODES[3292](VELOCITY_Z,0) = 0.000000; -NODES[3308](VELOCITY_X,0) = 0.000000; -NODES[3308](VELOCITY_Y,0) = 0.000000; -NODES[3308](VELOCITY_Z,0) = 0.000000; -NODES[3323](VELOCITY_X,0) = 0.000000; -NODES[3323](VELOCITY_Y,0) = 0.000000; -NODES[3323](VELOCITY_Z,0) = 0.000000; -NODES[3328](VELOCITY_X,0) = 0.000000; -NODES[3328](VELOCITY_Y,0) = 0.000000; -NODES[3328](VELOCITY_Z,0) = 0.000000; -NODES[3348](VELOCITY_X,0) = 0.000000; -NODES[3348](VELOCITY_Y,0) = 0.000000; -NODES[3348](VELOCITY_Z,0) = 0.000000; -NODES[3349](VELOCITY_X,0) = 0.000000; -NODES[3349](VELOCITY_Y,0) = 0.000000; -NODES[3349](VELOCITY_Z,0) = 0.000000; -NODES[3370](VELOCITY_X,0) = 0.000000; -NODES[3370](VELOCITY_Y,0) = 0.000000; -NODES[3370](VELOCITY_Z,0) = 0.000000; -NODES[3375](VELOCITY_X,0) = 0.000000; -NODES[3375](VELOCITY_Y,0) = 0.000000; -NODES[3375](VELOCITY_Z,0) = 0.000000; -NODES[3393](VELOCITY_X,0) = 0.000000; -NODES[3393](VELOCITY_Y,0) = 0.000000; -NODES[3393](VELOCITY_Z,0) = 0.000000; -NODES[3401](VELOCITY_X,0) = 0.000000; -NODES[3401](VELOCITY_Y,0) = 0.000000; -NODES[3401](VELOCITY_Z,0) = 0.000000; -NODES[3414](VELOCITY_X,0) = 0.000000; -NODES[3414](VELOCITY_Y,0) = 0.000000; -NODES[3414](VELOCITY_Z,0) = 0.000000; -NODES[3426](VELOCITY_X,0) = 0.000000; -NODES[3426](VELOCITY_Y,0) = 0.000000; -NODES[3426](VELOCITY_Z,0) = 0.000000; -NODES[3436](VELOCITY_X,0) = 0.000000; -NODES[3436](VELOCITY_Y,0) = 0.000000; -NODES[3436](VELOCITY_Z,0) = 0.000000; -NODES[3457](VELOCITY_X,0) = 0.000000; -NODES[3457](VELOCITY_Y,0) = 0.000000; -NODES[3457](VELOCITY_Z,0) = 0.000000; -NODES[3459](VELOCITY_X,0) = 0.000000; -NODES[3459](VELOCITY_Y,0) = 0.000000; -NODES[3459](VELOCITY_Z,0) = 0.000000; -NODES[3477](VELOCITY_X,0) = 0.000000; -NODES[3477](VELOCITY_Y,0) = 0.000000; -NODES[3477](VELOCITY_Z,0) = 0.000000; -NODES[3485](VELOCITY_X,0) = 0.000000; -NODES[3485](VELOCITY_Y,0) = 0.000000; -NODES[3485](VELOCITY_Z,0) = 0.000000; -NODES[3495](VELOCITY_X,0) = 0.000000; -NODES[3495](VELOCITY_Y,0) = 0.000000; -NODES[3495](VELOCITY_Z,0) = 0.000000; -NODES[3512](VELOCITY_X,0) = 0.000000; -NODES[3512](VELOCITY_Y,0) = 0.000000; -NODES[3512](VELOCITY_Z,0) = 0.000000; -NODES[3518](VELOCITY_X,0) = 0.000000; -NODES[3518](VELOCITY_Y,0) = 0.000000; -NODES[3518](VELOCITY_Z,0) = 0.000000; -NODES[3538](VELOCITY_X,0) = 0.000000; -NODES[3538](VELOCITY_Y,0) = 0.000000; -NODES[3538](VELOCITY_Z,0) = 0.000000; -NODES[3541](VELOCITY_X,0) = 0.000000; -NODES[3541](VELOCITY_Y,0) = 0.000000; -NODES[3541](VELOCITY_Z,0) = 0.000000; -NODES[3563](VELOCITY_X,0) = 0.000000; -NODES[3563](VELOCITY_Y,0) = 0.000000; -NODES[3563](VELOCITY_Z,0) = 0.000000; -NODES[3564](VELOCITY_X,0) = 0.000000; -NODES[3564](VELOCITY_Y,0) = 0.000000; -NODES[3564](VELOCITY_Z,0) = 0.000000; -NODES[3586](VELOCITY_X,0) = 0.000000; -NODES[3586](VELOCITY_Y,0) = 0.000000; -NODES[3586](VELOCITY_Z,0) = 0.000000; -NODES[3587](VELOCITY_X,0) = 0.000000; -NODES[3587](VELOCITY_Y,0) = 0.000000; -NODES[3587](VELOCITY_Z,0) = 0.000000; -NODES[3609](VELOCITY_X,0) = 0.000000; -NODES[3609](VELOCITY_Y,0) = 0.000000; -NODES[3609](VELOCITY_Z,0) = 0.000000; -NODES[3617](VELOCITY_X,0) = 0.000000; -NODES[3617](VELOCITY_Y,0) = 0.000000; -NODES[3617](VELOCITY_Z,0) = 0.000000; -NODES[3632](VELOCITY_X,0) = 0.000000; -NODES[3632](VELOCITY_Y,0) = 0.000000; -NODES[3632](VELOCITY_Z,0) = 0.000000; -NODES[3648](VELOCITY_X,0) = 0.000000; -NODES[3648](VELOCITY_Y,0) = 0.000000; -NODES[3648](VELOCITY_Z,0) = 0.000000; -NODES[3649](VELOCITY_X,0) = 0.000000; -NODES[3649](VELOCITY_Y,0) = 0.000000; -NODES[3649](VELOCITY_Z,0) = 0.000000; -NODES[3650](VELOCITY_X,0) = 0.000000; -NODES[3650](VELOCITY_Y,0) = 0.000000; -NODES[3650](VELOCITY_Z,0) = 0.000000; -NODES[3651](VELOCITY_X,0) = 0.000000; -NODES[3651](VELOCITY_Y,0) = 0.000000; -NODES[3651](VELOCITY_Z,0) = 0.000000; -NODES[3653](VELOCITY_X,0) = 0.000000; -NODES[3653](VELOCITY_Y,0) = 0.000000; -NODES[3653](VELOCITY_Z,0) = 0.000000; -NODES[3654](VELOCITY_X,0) = 0.000000; -NODES[3654](VELOCITY_Y,0) = 0.000000; -NODES[3654](VELOCITY_Z,0) = 0.000000; -NODES[3656](VELOCITY_X,0) = 0.000000; -NODES[3656](VELOCITY_Y,0) = 0.000000; -NODES[3656](VELOCITY_Z,0) = 0.000000; -NODES[3657](VELOCITY_X,0) = 0.000000; -NODES[3657](VELOCITY_Y,0) = 0.000000; -NODES[3657](VELOCITY_Z,0) = 0.000000; -NODES[3659](VELOCITY_X,0) = 0.000000; -NODES[3659](VELOCITY_Y,0) = 0.000000; -NODES[3659](VELOCITY_Z,0) = 0.000000; -NODES[3661](VELOCITY_X,0) = 0.000000; -NODES[3661](VELOCITY_Y,0) = 0.000000; -NODES[3661](VELOCITY_Z,0) = 0.000000; -NODES[3664](VELOCITY_X,0) = 0.000000; -NODES[3664](VELOCITY_Y,0) = 0.000000; -NODES[3664](VELOCITY_Z,0) = 0.000000; -NODES[3665](VELOCITY_X,0) = 0.000000; -NODES[3665](VELOCITY_Y,0) = 0.000000; -NODES[3665](VELOCITY_Z,0) = 0.000000; -NODES[3666](VELOCITY_X,0) = 0.000000; -NODES[3666](VELOCITY_Y,0) = 0.000000; -NODES[3666](VELOCITY_Z,0) = 0.000000; -NODES[3667](VELOCITY_X,0) = 0.000000; -NODES[3667](VELOCITY_Y,0) = 0.000000; -NODES[3667](VELOCITY_Z,0) = 0.000000; -NODES[3668](VELOCITY_X,0) = 0.000000; -NODES[3668](VELOCITY_Y,0) = 0.000000; -NODES[3668](VELOCITY_Z,0) = 0.000000; -NODES[3669](VELOCITY_X,0) = 0.000000; -NODES[3669](VELOCITY_Y,0) = 0.000000; -NODES[3669](VELOCITY_Z,0) = 0.000000; -NODES[3670](VELOCITY_X,0) = 0.000000; -NODES[3670](VELOCITY_Y,0) = 0.000000; -NODES[3670](VELOCITY_Z,0) = 0.000000; -NODES[3671](VELOCITY_X,0) = 0.000000; -NODES[3671](VELOCITY_Y,0) = 0.000000; -NODES[3671](VELOCITY_Z,0) = 0.000000; -NODES[3683](VELOCITY_X,0) = 0.000000; -NODES[3683](VELOCITY_Y,0) = 0.000000; -NODES[3683](VELOCITY_Z,0) = 0.000000; -NODES[3689](VELOCITY_X,0) = 0.000000; -NODES[3689](VELOCITY_Y,0) = 0.000000; -NODES[3689](VELOCITY_Z,0) = 0.000000; -NODES[3692](VELOCITY_X,0) = 0.000000; -NODES[3692](VELOCITY_Y,0) = 0.000000; -NODES[3692](VELOCITY_Z,0) = 0.000000; -NODES[3694](VELOCITY_X,0) = 0.000000; -NODES[3694](VELOCITY_Y,0) = 0.000000; -NODES[3694](VELOCITY_Z,0) = 0.000000; -NODES[3697](VELOCITY_X,0) = 0.000000; -NODES[3697](VELOCITY_Y,0) = 0.000000; -NODES[3697](VELOCITY_Z,0) = 0.000000; -NODES[3698](VELOCITY_X,0) = 0.000000; -NODES[3698](VELOCITY_Y,0) = 0.000000; -NODES[3698](VELOCITY_Z,0) = 0.000000; -NODES[3699](VELOCITY_X,0) = 0.000000; -NODES[3699](VELOCITY_Y,0) = 0.000000; -NODES[3699](VELOCITY_Z,0) = 0.000000; -NODES[3700](VELOCITY_X,0) = 0.000000; -NODES[3700](VELOCITY_Y,0) = 0.000000; -NODES[3700](VELOCITY_Z,0) = 0.000000; -NODES[3705](VELOCITY_X,0) = 0.000000; -NODES[3705](VELOCITY_Y,0) = 0.000000; -NODES[3705](VELOCITY_Z,0) = 0.000000; -NODES[3716](VELOCITY_X,0) = 0.000000; -NODES[3716](VELOCITY_Y,0) = 0.000000; -NODES[3716](VELOCITY_Z,0) = 0.000000; -NODES[3721](VELOCITY_X,0) = 0.000000; -NODES[3721](VELOCITY_Y,0) = 0.000000; -NODES[3721](VELOCITY_Z,0) = 0.000000; -NODES[3724](VELOCITY_X,0) = 0.000000; -NODES[3724](VELOCITY_Y,0) = 0.000000; -NODES[3724](VELOCITY_Z,0) = 0.000000; -NODES[3725](VELOCITY_X,0) = 0.000000; -NODES[3725](VELOCITY_Y,0) = 0.000000; -NODES[3725](VELOCITY_Z,0) = 0.000000; -NODES[3727](VELOCITY_X,0) = 0.000000; -NODES[3727](VELOCITY_Y,0) = 0.000000; -NODES[3727](VELOCITY_Z,0) = 0.000000; -NODES[3729](VELOCITY_X,0) = 0.000000; -NODES[3729](VELOCITY_Y,0) = 0.000000; -NODES[3729](VELOCITY_Z,0) = 0.000000; -NODES[3735](VELOCITY_X,0) = 0.000000; -NODES[3735](VELOCITY_Y,0) = 0.000000; -NODES[3735](VELOCITY_Z,0) = 0.000000; -NODES[3745](VELOCITY_X,0) = 0.000000; -NODES[3745](VELOCITY_Y,0) = 0.000000; -NODES[3745](VELOCITY_Z,0) = 0.000000; -NODES[3750](VELOCITY_X,0) = 0.000000; -NODES[3750](VELOCITY_Y,0) = 0.000000; -NODES[3750](VELOCITY_Z,0) = 0.000000; -NODES[3751](VELOCITY_X,0) = 0.000000; -NODES[3751](VELOCITY_Y,0) = 0.000000; -NODES[3751](VELOCITY_Z,0) = 0.000000; -NODES[3754](VELOCITY_X,0) = 0.000000; -NODES[3754](VELOCITY_Y,0) = 0.000000; -NODES[3754](VELOCITY_Z,0) = 0.000000; -NODES[3755](VELOCITY_X,0) = 0.000000; -NODES[3755](VELOCITY_Y,0) = 0.000000; -NODES[3755](VELOCITY_Z,0) = 0.000000; -NODES[3765](VELOCITY_X,0) = 0.000000; -NODES[3765](VELOCITY_Y,0) = 0.000000; -NODES[3765](VELOCITY_Z,0) = 0.000000; -NODES[3774](VELOCITY_X,0) = 0.000000; -NODES[3774](VELOCITY_Y,0) = 0.000000; -NODES[3774](VELOCITY_Z,0) = 0.000000; -NODES[3777](VELOCITY_X,0) = 0.000000; -NODES[3777](VELOCITY_Y,0) = 0.000000; -NODES[3777](VELOCITY_Z,0) = 0.000000; -NODES[3778](VELOCITY_X,0) = 0.000000; -NODES[3778](VELOCITY_Y,0) = 0.000000; -NODES[3778](VELOCITY_Z,0) = 0.000000; -NODES[3782](VELOCITY_X,0) = 0.000000; -NODES[3782](VELOCITY_Y,0) = 0.000000; -NODES[3782](VELOCITY_Z,0) = 0.000000; -NODES[3783](VELOCITY_X,0) = 0.000000; -NODES[3783](VELOCITY_Y,0) = 0.000000; -NODES[3783](VELOCITY_Z,0) = 0.000000; -NODES[3799](VELOCITY_X,0) = 0.000000; -NODES[3799](VELOCITY_Y,0) = 0.000000; -NODES[3799](VELOCITY_Z,0) = 0.000000; -NODES[3803](VELOCITY_X,0) = 0.000000; -NODES[3803](VELOCITY_Y,0) = 0.000000; -NODES[3803](VELOCITY_Z,0) = 0.000000; -NODES[3805](VELOCITY_X,0) = 0.000000; -NODES[3805](VELOCITY_Y,0) = 0.000000; -NODES[3805](VELOCITY_Z,0) = 0.000000; -NODES[3807](VELOCITY_X,0) = 0.000000; -NODES[3807](VELOCITY_Y,0) = 0.000000; -NODES[3807](VELOCITY_Z,0) = 0.000000; -NODES[3810](VELOCITY_X,0) = 0.000000; -NODES[3810](VELOCITY_Y,0) = 0.000000; -NODES[3810](VELOCITY_Z,0) = 0.000000; -NODES[3824](VELOCITY_X,0) = 0.000000; -NODES[3824](VELOCITY_Y,0) = 0.000000; -NODES[3824](VELOCITY_Z,0) = 0.000000; -NODES[3826](VELOCITY_X,0) = 0.000000; -NODES[3826](VELOCITY_Y,0) = 0.000000; -NODES[3826](VELOCITY_Z,0) = 0.000000; -NODES[3831](VELOCITY_X,0) = 0.000000; -NODES[3831](VELOCITY_Y,0) = 0.000000; -NODES[3831](VELOCITY_Z,0) = 0.000000; -NODES[3833](VELOCITY_X,0) = 0.000000; -NODES[3833](VELOCITY_Y,0) = 0.000000; -NODES[3833](VELOCITY_Z,0) = 0.000000; -NODES[3843](VELOCITY_X,0) = 0.000000; -NODES[3843](VELOCITY_Y,0) = 0.000000; -NODES[3843](VELOCITY_Z,0) = 0.000000; -NODES[3851](VELOCITY_X,0) = 0.000000; -NODES[3851](VELOCITY_Y,0) = 0.000000; -NODES[3851](VELOCITY_Z,0) = 0.000000; -NODES[3852](VELOCITY_X,0) = 0.000000; -NODES[3852](VELOCITY_Y,0) = 0.000000; -NODES[3852](VELOCITY_Z,0) = 0.000000; -NODES[3857](VELOCITY_X,0) = 0.000000; -NODES[3857](VELOCITY_Y,0) = 0.000000; -NODES[3857](VELOCITY_Z,0) = 0.000000; -NODES[3862](VELOCITY_X,0) = 0.000000; -NODES[3862](VELOCITY_Y,0) = 0.000000; -NODES[3862](VELOCITY_Z,0) = 0.000000; -NODES[3874](VELOCITY_X,0) = 0.000000; -NODES[3874](VELOCITY_Y,0) = 0.000000; -NODES[3874](VELOCITY_Z,0) = 0.000000; -NODES[3875](VELOCITY_X,0) = 0.000000; -NODES[3875](VELOCITY_Y,0) = 0.000000; -NODES[3875](VELOCITY_Z,0) = 0.000000; -NODES[3879](VELOCITY_X,0) = 0.000000; -NODES[3879](VELOCITY_Y,0) = 0.000000; -NODES[3879](VELOCITY_Z,0) = 0.000000; -NODES[3888](VELOCITY_X,0) = 0.000000; -NODES[3888](VELOCITY_Y,0) = 0.000000; -NODES[3888](VELOCITY_Z,0) = 0.000000; -NODES[3898](VELOCITY_X,0) = 0.000000; -NODES[3898](VELOCITY_Y,0) = 0.000000; -NODES[3898](VELOCITY_Z,0) = 0.000000; -NODES[3900](VELOCITY_X,0) = 0.000000; -NODES[3900](VELOCITY_Y,0) = 0.000000; -NODES[3900](VELOCITY_Z,0) = 0.000000; -NODES[3905](VELOCITY_X,0) = 0.000000; -NODES[3905](VELOCITY_Y,0) = 0.000000; -NODES[3905](VELOCITY_Z,0) = 0.000000; -NODES[3912](VELOCITY_X,0) = 0.000000; -NODES[3912](VELOCITY_Y,0) = 0.000000; -NODES[3912](VELOCITY_Z,0) = 0.000000; -NODES[3919](VELOCITY_X,0) = 0.000000; -NODES[3919](VELOCITY_Y,0) = 0.000000; -NODES[3919](VELOCITY_Z,0) = 0.000000; -NODES[3923](VELOCITY_X,0) = 0.000000; -NODES[3923](VELOCITY_Y,0) = 0.000000; -NODES[3923](VELOCITY_Z,0) = 0.000000; -NODES[3931](VELOCITY_X,0) = 0.000000; -NODES[3931](VELOCITY_Y,0) = 0.000000; -NODES[3931](VELOCITY_Z,0) = 0.000000; -NODES[3939](VELOCITY_X,0) = 0.000000; -NODES[3939](VELOCITY_Y,0) = 0.000000; -NODES[3939](VELOCITY_Z,0) = 0.000000; -NODES[3945](VELOCITY_X,0) = 0.000000; -NODES[3945](VELOCITY_Y,0) = 0.000000; -NODES[3945](VELOCITY_Z,0) = 0.000000; -NODES[3950](VELOCITY_X,0) = 0.000000; -NODES[3950](VELOCITY_Y,0) = 0.000000; -NODES[3950](VELOCITY_Z,0) = 0.000000; -NODES[3957](VELOCITY_X,0) = 0.000000; -NODES[3957](VELOCITY_Y,0) = 0.000000; -NODES[3957](VELOCITY_Z,0) = 0.000000; -NODES[3965](VELOCITY_X,0) = 0.000000; -NODES[3965](VELOCITY_Y,0) = 0.000000; -NODES[3965](VELOCITY_Z,0) = 0.000000; -NODES[3968](VELOCITY_X,0) = 0.000000; -NODES[3968](VELOCITY_Y,0) = 0.000000; -NODES[3968](VELOCITY_Z,0) = 0.000000; -NODES[3976](VELOCITY_X,0) = 0.000000; -NODES[3976](VELOCITY_Y,0) = 0.000000; -NODES[3976](VELOCITY_Z,0) = 0.000000; -NODES[3986](VELOCITY_X,0) = 0.000000; -NODES[3986](VELOCITY_Y,0) = 0.000000; -NODES[3986](VELOCITY_Z,0) = 0.000000; -NODES[3990](VELOCITY_X,0) = 0.000000; -NODES[3990](VELOCITY_Y,0) = 0.000000; -NODES[3990](VELOCITY_Z,0) = 0.000000; -NODES[3995](VELOCITY_X,0) = 0.000000; -NODES[3995](VELOCITY_Y,0) = 0.000000; -NODES[3995](VELOCITY_Z,0) = 0.000000; -NODES[4003](VELOCITY_X,0) = 0.000000; -NODES[4003](VELOCITY_Y,0) = 0.000000; -NODES[4003](VELOCITY_Z,0) = 0.000000; -NODES[4014](VELOCITY_X,0) = 0.000000; -NODES[4014](VELOCITY_Y,0) = 0.000000; -NODES[4014](VELOCITY_Z,0) = 0.000000; -NODES[4015](VELOCITY_X,0) = 0.000000; -NODES[4015](VELOCITY_Y,0) = 0.000000; -NODES[4015](VELOCITY_Z,0) = 0.000000; -NODES[4024](VELOCITY_X,0) = 0.000000; -NODES[4024](VELOCITY_Y,0) = 0.000000; -NODES[4024](VELOCITY_Z,0) = 0.000000; -NODES[4033](VELOCITY_X,0) = 0.000000; -NODES[4033](VELOCITY_Y,0) = 0.000000; -NODES[4033](VELOCITY_Z,0) = 0.000000; -NODES[4039](VELOCITY_X,0) = 0.000000; -NODES[4039](VELOCITY_Y,0) = 0.000000; -NODES[4039](VELOCITY_Z,0) = 0.000000; -NODES[4044](VELOCITY_X,0) = 0.000000; -NODES[4044](VELOCITY_Y,0) = 0.000000; -NODES[4044](VELOCITY_Z,0) = 0.000000; -NODES[4053](VELOCITY_X,0) = 0.000000; -NODES[4053](VELOCITY_Y,0) = 0.000000; -NODES[4053](VELOCITY_Z,0) = 0.000000; -NODES[4061](VELOCITY_X,0) = 0.000000; -NODES[4061](VELOCITY_Y,0) = 0.000000; -NODES[4061](VELOCITY_Z,0) = 0.000000; -NODES[4065](VELOCITY_X,0) = 0.000000; -NODES[4065](VELOCITY_Y,0) = 0.000000; -NODES[4065](VELOCITY_Z,0) = 0.000000; -NODES[4072](VELOCITY_X,0) = 0.000000; -NODES[4072](VELOCITY_Y,0) = 0.000000; -NODES[4072](VELOCITY_Z,0) = 0.000000; -NODES[4086](VELOCITY_X,0) = 0.000000; -NODES[4086](VELOCITY_Y,0) = 0.000000; -NODES[4086](VELOCITY_Z,0) = 0.000000; -NODES[4087](VELOCITY_X,0) = 0.000000; -NODES[4087](VELOCITY_Y,0) = 0.000000; -NODES[4087](VELOCITY_Z,0) = 0.000000; -NODES[4094](VELOCITY_X,0) = 0.000000; -NODES[4094](VELOCITY_Y,0) = 0.000000; -NODES[4094](VELOCITY_Z,0) = 0.000000; -NODES[4106](VELOCITY_X,0) = 0.000000; -NODES[4106](VELOCITY_Y,0) = 0.000000; -NODES[4106](VELOCITY_Z,0) = 0.000000; -NODES[4109](VELOCITY_X,0) = 0.000000; -NODES[4109](VELOCITY_Y,0) = 0.000000; -NODES[4109](VELOCITY_Z,0) = 0.000000; -NODES[4118](VELOCITY_X,0) = 0.000000; -NODES[4118](VELOCITY_Y,0) = 0.000000; -NODES[4118](VELOCITY_Z,0) = 0.000000; -NODES[4128](VELOCITY_X,0) = 0.000000; -NODES[4128](VELOCITY_Y,0) = 0.000000; -NODES[4128](VELOCITY_Z,0) = 0.000000; -NODES[4132](VELOCITY_X,0) = 0.000000; -NODES[4132](VELOCITY_Y,0) = 0.000000; -NODES[4132](VELOCITY_Z,0) = 0.000000; -NODES[4139](VELOCITY_X,0) = 0.000000; -NODES[4139](VELOCITY_Y,0) = 0.000000; -NODES[4139](VELOCITY_Z,0) = 0.000000; -NODES[4149](VELOCITY_X,0) = 0.000000; -NODES[4149](VELOCITY_Y,0) = 0.000000; -NODES[4149](VELOCITY_Z,0) = 0.000000; -NODES[4157](VELOCITY_X,0) = 0.000000; -NODES[4157](VELOCITY_Y,0) = 0.000000; -NODES[4157](VELOCITY_Z,0) = 0.000000; -NODES[4163](VELOCITY_X,0) = 0.000000; -NODES[4163](VELOCITY_Y,0) = 0.000000; -NODES[4163](VELOCITY_Z,0) = 0.000000; -NODES[4173](VELOCITY_X,0) = 0.000000; -NODES[4173](VELOCITY_Y,0) = 0.000000; -NODES[4173](VELOCITY_Z,0) = 0.000000; -NODES[4180](VELOCITY_X,0) = 0.000000; -NODES[4180](VELOCITY_Y,0) = 0.000000; -NODES[4180](VELOCITY_Z,0) = 0.000000; -NODES[4186](VELOCITY_X,0) = 0.000000; -NODES[4186](VELOCITY_Y,0) = 0.000000; -NODES[4186](VELOCITY_Z,0) = 0.000000; -NODES[4196](VELOCITY_X,0) = 0.000000; -NODES[4196](VELOCITY_Y,0) = 0.000000; -NODES[4196](VELOCITY_Z,0) = 0.000000; -NODES[4201](VELOCITY_X,0) = 0.000000; -NODES[4201](VELOCITY_Y,0) = 0.000000; -NODES[4201](VELOCITY_Z,0) = 0.000000; -NODES[4207](VELOCITY_X,0) = 0.000000; -NODES[4207](VELOCITY_Y,0) = 0.000000; -NODES[4207](VELOCITY_Z,0) = 0.000000; -NODES[4214](VELOCITY_X,0) = 0.000000; -NODES[4214](VELOCITY_Y,0) = 0.000000; -NODES[4214](VELOCITY_Z,0) = 0.000000; -NODES[4222](VELOCITY_X,0) = 0.000000; -NODES[4222](VELOCITY_Y,0) = 0.000000; -NODES[4222](VELOCITY_Z,0) = 0.000000; -NODES[4226](VELOCITY_X,0) = 0.000000; -NODES[4226](VELOCITY_Y,0) = 0.000000; -NODES[4226](VELOCITY_Z,0) = 0.000000; -NODES[4234](VELOCITY_X,0) = 0.000000; -NODES[4234](VELOCITY_Y,0) = 0.000000; -NODES[4234](VELOCITY_Z,0) = 0.000000; -NODES[4240](VELOCITY_X,0) = 0.000000; -NODES[4240](VELOCITY_Y,0) = 0.000000; -NODES[4240](VELOCITY_Z,0) = 0.000000; -NODES[4242](VELOCITY_X,0) = 0.000000; -NODES[4242](VELOCITY_Y,0) = 0.000000; -NODES[4242](VELOCITY_Z,0) = 0.000000; -NODES[4248](VELOCITY_X,0) = 0.000000; -NODES[4248](VELOCITY_Y,0) = 0.000000; -NODES[4248](VELOCITY_Z,0) = 0.000000; -NODES[4255](VELOCITY_X,0) = 0.000000; -NODES[4255](VELOCITY_Y,0) = 0.000000; -NODES[4255](VELOCITY_Z,0) = 0.000000; -NODES[4257](VELOCITY_X,0) = 0.000000; -NODES[4257](VELOCITY_Y,0) = 0.000000; -NODES[4257](VELOCITY_Z,0) = 0.000000; -NODES[4263](VELOCITY_X,0) = 0.000000; -NODES[4263](VELOCITY_Y,0) = 0.000000; -NODES[4263](VELOCITY_Z,0) = 0.000000; -NODES[4268](VELOCITY_X,0) = 0.000000; -NODES[4268](VELOCITY_Y,0) = 0.000000; -NODES[4268](VELOCITY_Z,0) = 0.000000; -NODES[4270](VELOCITY_X,0) = 0.000000; -NODES[4270](VELOCITY_Y,0) = 0.000000; -NODES[4270](VELOCITY_Z,0) = 0.000000; -NODES[4275](VELOCITY_X,0) = 0.000000; -NODES[4275](VELOCITY_Y,0) = 0.000000; -NODES[4275](VELOCITY_Z,0) = 0.000000; -NODES[4276](VELOCITY_X,0) = 0.000000; -NODES[4276](VELOCITY_Y,0) = 0.000000; -NODES[4276](VELOCITY_Z,0) = 0.000000; -NODES[4281](VELOCITY_X,0) = 0.000000; -NODES[4281](VELOCITY_Y,0) = 0.000000; -NODES[4281](VELOCITY_Z,0) = 0.000000; -NODES[4284](VELOCITY_X,0) = 0.000000; -NODES[4284](VELOCITY_Y,0) = 0.000000; -NODES[4284](VELOCITY_Z,0) = 0.000000; -NODES[4286](VELOCITY_X,0) = 0.000000; -NODES[4286](VELOCITY_Y,0) = 0.000000; -NODES[4286](VELOCITY_Z,0) = 0.000000; -NODES[4289](VELOCITY_X,0) = 0.000000; -NODES[4289](VELOCITY_Y,0) = 0.000000; -NODES[4289](VELOCITY_Z,0) = 0.000000; -NODES[4292](VELOCITY_X,0) = 0.000000; -NODES[4292](VELOCITY_Y,0) = 0.000000; -NODES[4292](VELOCITY_Z,0) = 0.000000; -NODES[4293](VELOCITY_X,0) = 0.000000; -NODES[4293](VELOCITY_Y,0) = 0.000000; -NODES[4293](VELOCITY_Z,0) = 0.000000; -NODES[4295](VELOCITY_X,0) = 0.000000; -NODES[4295](VELOCITY_Y,0) = 0.000000; -NODES[4295](VELOCITY_Z,0) = 0.000000; -NODES[4296](VELOCITY_X,0) = 0.000000; -NODES[4296](VELOCITY_Y,0) = 0.000000; -NODES[4296](VELOCITY_Z,0) = 0.000000; -NODES[4297](VELOCITY_X,0) = 0.000000; -NODES[4297](VELOCITY_Y,0) = 0.000000; -NODES[4297](VELOCITY_Z,0) = 0.000000; -NODES[4298](VELOCITY_X,0) = 0.000000; -NODES[4298](VELOCITY_Y,0) = 0.000000; -NODES[4298](VELOCITY_Z,0) = 0.000000; -NODES[4299](VELOCITY_X,0) = 0.000000; -NODES[4299](VELOCITY_Y,0) = 0.000000; -NODES[4299](VELOCITY_Z,0) = 0.000000; -NODES[167](BODY_FORCE_X,0) = 0.000000; -NODES[167](BODY_FORCE_Y,0) = -9.810000; -NODES[167](BODY_FORCE_Z,0) = 0.000000; -NODES[168](BODY_FORCE_X,0) = 0.000000; -NODES[168](BODY_FORCE_Y,0) = -9.810000; -NODES[168](BODY_FORCE_Z,0) = 0.000000; -NODES[169](BODY_FORCE_X,0) = 0.000000; -NODES[169](BODY_FORCE_Y,0) = -9.810000; -NODES[169](BODY_FORCE_Z,0) = 0.000000; -NODES[170](BODY_FORCE_X,0) = 0.000000; -NODES[170](BODY_FORCE_Y,0) = -9.810000; -NODES[170](BODY_FORCE_Z,0) = 0.000000; -NODES[171](BODY_FORCE_X,0) = 0.000000; -NODES[171](BODY_FORCE_Y,0) = -9.810000; -NODES[171](BODY_FORCE_Z,0) = 0.000000; -NODES[172](BODY_FORCE_X,0) = 0.000000; -NODES[172](BODY_FORCE_Y,0) = -9.810000; -NODES[172](BODY_FORCE_Z,0) = 0.000000; -NODES[173](BODY_FORCE_X,0) = 0.000000; -NODES[173](BODY_FORCE_Y,0) = -9.810000; -NODES[173](BODY_FORCE_Z,0) = 0.000000; -NODES[174](BODY_FORCE_X,0) = 0.000000; -NODES[174](BODY_FORCE_Y,0) = -9.810000; -NODES[174](BODY_FORCE_Z,0) = 0.000000; -NODES[175](BODY_FORCE_X,0) = 0.000000; -NODES[175](BODY_FORCE_Y,0) = -9.810000; -NODES[175](BODY_FORCE_Z,0) = 0.000000; -NODES[176](BODY_FORCE_X,0) = 0.000000; -NODES[176](BODY_FORCE_Y,0) = -9.810000; -NODES[176](BODY_FORCE_Z,0) = 0.000000; -NODES[177](BODY_FORCE_X,0) = 0.000000; -NODES[177](BODY_FORCE_Y,0) = -9.810000; -NODES[177](BODY_FORCE_Z,0) = 0.000000; -NODES[178](BODY_FORCE_X,0) = 0.000000; -NODES[178](BODY_FORCE_Y,0) = -9.810000; -NODES[178](BODY_FORCE_Z,0) = 0.000000; -NODES[179](BODY_FORCE_X,0) = 0.000000; -NODES[179](BODY_FORCE_Y,0) = -9.810000; -NODES[179](BODY_FORCE_Z,0) = 0.000000; -NODES[180](BODY_FORCE_X,0) = 0.000000; -NODES[180](BODY_FORCE_Y,0) = -9.810000; -NODES[180](BODY_FORCE_Z,0) = 0.000000; -NODES[181](BODY_FORCE_X,0) = 0.000000; -NODES[181](BODY_FORCE_Y,0) = -9.810000; -NODES[181](BODY_FORCE_Z,0) = 0.000000; -NODES[182](BODY_FORCE_X,0) = 0.000000; -NODES[182](BODY_FORCE_Y,0) = -9.810000; -NODES[182](BODY_FORCE_Z,0) = 0.000000; -NODES[184](BODY_FORCE_X,0) = 0.000000; -NODES[184](BODY_FORCE_Y,0) = -9.810000; -NODES[184](BODY_FORCE_Z,0) = 0.000000; -NODES[185](BODY_FORCE_X,0) = 0.000000; -NODES[185](BODY_FORCE_Y,0) = -9.810000; -NODES[185](BODY_FORCE_Z,0) = 0.000000; -NODES[186](BODY_FORCE_X,0) = 0.000000; -NODES[186](BODY_FORCE_Y,0) = -9.810000; -NODES[186](BODY_FORCE_Z,0) = 0.000000; -NODES[187](BODY_FORCE_X,0) = 0.000000; -NODES[187](BODY_FORCE_Y,0) = -9.810000; -NODES[187](BODY_FORCE_Z,0) = 0.000000; -NODES[188](BODY_FORCE_X,0) = 0.000000; -NODES[188](BODY_FORCE_Y,0) = -9.810000; -NODES[188](BODY_FORCE_Z,0) = 0.000000; -NODES[189](BODY_FORCE_X,0) = 0.000000; -NODES[189](BODY_FORCE_Y,0) = -9.810000; -NODES[189](BODY_FORCE_Z,0) = 0.000000; -NODES[190](BODY_FORCE_X,0) = 0.000000; -NODES[190](BODY_FORCE_Y,0) = -9.810000; -NODES[190](BODY_FORCE_Z,0) = 0.000000; -NODES[191](BODY_FORCE_X,0) = 0.000000; -NODES[191](BODY_FORCE_Y,0) = -9.810000; -NODES[191](BODY_FORCE_Z,0) = 0.000000; -NODES[192](BODY_FORCE_X,0) = 0.000000; -NODES[192](BODY_FORCE_Y,0) = -9.810000; -NODES[192](BODY_FORCE_Z,0) = 0.000000; -NODES[193](BODY_FORCE_X,0) = 0.000000; -NODES[193](BODY_FORCE_Y,0) = -9.810000; -NODES[193](BODY_FORCE_Z,0) = 0.000000; -NODES[194](BODY_FORCE_X,0) = 0.000000; -NODES[194](BODY_FORCE_Y,0) = -9.810000; -NODES[194](BODY_FORCE_Z,0) = 0.000000; -NODES[195](BODY_FORCE_X,0) = 0.000000; -NODES[195](BODY_FORCE_Y,0) = -9.810000; -NODES[195](BODY_FORCE_Z,0) = 0.000000; -NODES[196](BODY_FORCE_X,0) = 0.000000; -NODES[196](BODY_FORCE_Y,0) = -9.810000; -NODES[196](BODY_FORCE_Z,0) = 0.000000; -NODES[197](BODY_FORCE_X,0) = 0.000000; -NODES[197](BODY_FORCE_Y,0) = -9.810000; -NODES[197](BODY_FORCE_Z,0) = 0.000000; -NODES[198](BODY_FORCE_X,0) = 0.000000; -NODES[198](BODY_FORCE_Y,0) = -9.810000; -NODES[198](BODY_FORCE_Z,0) = 0.000000; -NODES[199](BODY_FORCE_X,0) = 0.000000; -NODES[199](BODY_FORCE_Y,0) = -9.810000; -NODES[199](BODY_FORCE_Z,0) = 0.000000; -NODES[200](BODY_FORCE_X,0) = 0.000000; -NODES[200](BODY_FORCE_Y,0) = -9.810000; -NODES[200](BODY_FORCE_Z,0) = 0.000000; -NODES[201](BODY_FORCE_X,0) = 0.000000; -NODES[201](BODY_FORCE_Y,0) = -9.810000; -NODES[201](BODY_FORCE_Z,0) = 0.000000; -NODES[202](BODY_FORCE_X,0) = 0.000000; -NODES[202](BODY_FORCE_Y,0) = -9.810000; -NODES[202](BODY_FORCE_Z,0) = 0.000000; -NODES[203](BODY_FORCE_X,0) = 0.000000; -NODES[203](BODY_FORCE_Y,0) = -9.810000; -NODES[203](BODY_FORCE_Z,0) = 0.000000; -NODES[205](BODY_FORCE_X,0) = 0.000000; -NODES[205](BODY_FORCE_Y,0) = -9.810000; -NODES[205](BODY_FORCE_Z,0) = 0.000000; -NODES[206](BODY_FORCE_X,0) = 0.000000; -NODES[206](BODY_FORCE_Y,0) = -9.810000; -NODES[206](BODY_FORCE_Z,0) = 0.000000; -NODES[207](BODY_FORCE_X,0) = 0.000000; -NODES[207](BODY_FORCE_Y,0) = -9.810000; -NODES[207](BODY_FORCE_Z,0) = 0.000000; -NODES[208](BODY_FORCE_X,0) = 0.000000; -NODES[208](BODY_FORCE_Y,0) = -9.810000; -NODES[208](BODY_FORCE_Z,0) = 0.000000; -NODES[209](BODY_FORCE_X,0) = 0.000000; -NODES[209](BODY_FORCE_Y,0) = -9.810000; -NODES[209](BODY_FORCE_Z,0) = 0.000000; -NODES[210](BODY_FORCE_X,0) = 0.000000; -NODES[210](BODY_FORCE_Y,0) = -9.810000; -NODES[210](BODY_FORCE_Z,0) = 0.000000; -NODES[211](BODY_FORCE_X,0) = 0.000000; -NODES[211](BODY_FORCE_Y,0) = -9.810000; -NODES[211](BODY_FORCE_Z,0) = 0.000000; -NODES[212](BODY_FORCE_X,0) = 0.000000; -NODES[212](BODY_FORCE_Y,0) = -9.810000; -NODES[212](BODY_FORCE_Z,0) = 0.000000; -NODES[213](BODY_FORCE_X,0) = 0.000000; -NODES[213](BODY_FORCE_Y,0) = -9.810000; -NODES[213](BODY_FORCE_Z,0) = 0.000000; -NODES[214](BODY_FORCE_X,0) = 0.000000; -NODES[214](BODY_FORCE_Y,0) = -9.810000; -NODES[214](BODY_FORCE_Z,0) = 0.000000; -NODES[215](BODY_FORCE_X,0) = 0.000000; -NODES[215](BODY_FORCE_Y,0) = -9.810000; -NODES[215](BODY_FORCE_Z,0) = 0.000000; -NODES[216](BODY_FORCE_X,0) = 0.000000; -NODES[216](BODY_FORCE_Y,0) = -9.810000; -NODES[216](BODY_FORCE_Z,0) = 0.000000; -NODES[217](BODY_FORCE_X,0) = 0.000000; -NODES[217](BODY_FORCE_Y,0) = -9.810000; -NODES[217](BODY_FORCE_Z,0) = 0.000000; -NODES[218](BODY_FORCE_X,0) = 0.000000; -NODES[218](BODY_FORCE_Y,0) = -9.810000; -NODES[218](BODY_FORCE_Z,0) = 0.000000; -NODES[219](BODY_FORCE_X,0) = 0.000000; -NODES[219](BODY_FORCE_Y,0) = -9.810000; -NODES[219](BODY_FORCE_Z,0) = 0.000000; -NODES[220](BODY_FORCE_X,0) = 0.000000; -NODES[220](BODY_FORCE_Y,0) = -9.810000; -NODES[220](BODY_FORCE_Z,0) = 0.000000; -NODES[221](BODY_FORCE_X,0) = 0.000000; -NODES[221](BODY_FORCE_Y,0) = -9.810000; -NODES[221](BODY_FORCE_Z,0) = 0.000000; -NODES[222](BODY_FORCE_X,0) = 0.000000; -NODES[222](BODY_FORCE_Y,0) = -9.810000; -NODES[222](BODY_FORCE_Z,0) = 0.000000; -NODES[223](BODY_FORCE_X,0) = 0.000000; -NODES[223](BODY_FORCE_Y,0) = -9.810000; -NODES[223](BODY_FORCE_Z,0) = 0.000000; -NODES[224](BODY_FORCE_X,0) = 0.000000; -NODES[224](BODY_FORCE_Y,0) = -9.810000; -NODES[224](BODY_FORCE_Z,0) = 0.000000; -NODES[225](BODY_FORCE_X,0) = 0.000000; -NODES[225](BODY_FORCE_Y,0) = -9.810000; -NODES[225](BODY_FORCE_Z,0) = 0.000000; -NODES[226](BODY_FORCE_X,0) = 0.000000; -NODES[226](BODY_FORCE_Y,0) = -9.810000; -NODES[226](BODY_FORCE_Z,0) = 0.000000; -NODES[227](BODY_FORCE_X,0) = 0.000000; -NODES[227](BODY_FORCE_Y,0) = -9.810000; -NODES[227](BODY_FORCE_Z,0) = 0.000000; -NODES[228](BODY_FORCE_X,0) = 0.000000; -NODES[228](BODY_FORCE_Y,0) = -9.810000; -NODES[228](BODY_FORCE_Z,0) = 0.000000; -NODES[229](BODY_FORCE_X,0) = 0.000000; -NODES[229](BODY_FORCE_Y,0) = -9.810000; -NODES[229](BODY_FORCE_Z,0) = 0.000000; -NODES[230](BODY_FORCE_X,0) = 0.000000; -NODES[230](BODY_FORCE_Y,0) = -9.810000; -NODES[230](BODY_FORCE_Z,0) = 0.000000; -NODES[232](BODY_FORCE_X,0) = 0.000000; -NODES[232](BODY_FORCE_Y,0) = -9.810000; -NODES[232](BODY_FORCE_Z,0) = 0.000000; -NODES[233](BODY_FORCE_X,0) = 0.000000; -NODES[233](BODY_FORCE_Y,0) = -9.810000; -NODES[233](BODY_FORCE_Z,0) = 0.000000; -NODES[234](BODY_FORCE_X,0) = 0.000000; -NODES[234](BODY_FORCE_Y,0) = -9.810000; -NODES[234](BODY_FORCE_Z,0) = 0.000000; -NODES[235](BODY_FORCE_X,0) = 0.000000; -NODES[235](BODY_FORCE_Y,0) = -9.810000; -NODES[235](BODY_FORCE_Z,0) = 0.000000; -NODES[236](BODY_FORCE_X,0) = 0.000000; -NODES[236](BODY_FORCE_Y,0) = -9.810000; -NODES[236](BODY_FORCE_Z,0) = 0.000000; -NODES[237](BODY_FORCE_X,0) = 0.000000; -NODES[237](BODY_FORCE_Y,0) = -9.810000; -NODES[237](BODY_FORCE_Z,0) = 0.000000; -NODES[238](BODY_FORCE_X,0) = 0.000000; -NODES[238](BODY_FORCE_Y,0) = -9.810000; -NODES[238](BODY_FORCE_Z,0) = 0.000000; -NODES[239](BODY_FORCE_X,0) = 0.000000; -NODES[239](BODY_FORCE_Y,0) = -9.810000; -NODES[239](BODY_FORCE_Z,0) = 0.000000; -NODES[240](BODY_FORCE_X,0) = 0.000000; -NODES[240](BODY_FORCE_Y,0) = -9.810000; -NODES[240](BODY_FORCE_Z,0) = 0.000000; -NODES[241](BODY_FORCE_X,0) = 0.000000; -NODES[241](BODY_FORCE_Y,0) = -9.810000; -NODES[241](BODY_FORCE_Z,0) = 0.000000; -NODES[242](BODY_FORCE_X,0) = 0.000000; -NODES[242](BODY_FORCE_Y,0) = -9.810000; -NODES[242](BODY_FORCE_Z,0) = 0.000000; -NODES[243](BODY_FORCE_X,0) = 0.000000; -NODES[243](BODY_FORCE_Y,0) = -9.810000; -NODES[243](BODY_FORCE_Z,0) = 0.000000; -NODES[244](BODY_FORCE_X,0) = 0.000000; -NODES[244](BODY_FORCE_Y,0) = -9.810000; -NODES[244](BODY_FORCE_Z,0) = 0.000000; -NODES[245](BODY_FORCE_X,0) = 0.000000; -NODES[245](BODY_FORCE_Y,0) = -9.810000; -NODES[245](BODY_FORCE_Z,0) = 0.000000; -NODES[246](BODY_FORCE_X,0) = 0.000000; -NODES[246](BODY_FORCE_Y,0) = -9.810000; -NODES[246](BODY_FORCE_Z,0) = 0.000000; -NODES[247](BODY_FORCE_X,0) = 0.000000; -NODES[247](BODY_FORCE_Y,0) = -9.810000; -NODES[247](BODY_FORCE_Z,0) = 0.000000; -NODES[248](BODY_FORCE_X,0) = 0.000000; -NODES[248](BODY_FORCE_Y,0) = -9.810000; -NODES[248](BODY_FORCE_Z,0) = 0.000000; -NODES[249](BODY_FORCE_X,0) = 0.000000; -NODES[249](BODY_FORCE_Y,0) = -9.810000; -NODES[249](BODY_FORCE_Z,0) = 0.000000; -NODES[250](BODY_FORCE_X,0) = 0.000000; -NODES[250](BODY_FORCE_Y,0) = -9.810000; -NODES[250](BODY_FORCE_Z,0) = 0.000000; -NODES[251](BODY_FORCE_X,0) = 0.000000; -NODES[251](BODY_FORCE_Y,0) = -9.810000; -NODES[251](BODY_FORCE_Z,0) = 0.000000; -NODES[252](BODY_FORCE_X,0) = 0.000000; -NODES[252](BODY_FORCE_Y,0) = -9.810000; -NODES[252](BODY_FORCE_Z,0) = 0.000000; -NODES[253](BODY_FORCE_X,0) = 0.000000; -NODES[253](BODY_FORCE_Y,0) = -9.810000; -NODES[253](BODY_FORCE_Z,0) = 0.000000; -NODES[254](BODY_FORCE_X,0) = 0.000000; -NODES[254](BODY_FORCE_Y,0) = -9.810000; -NODES[254](BODY_FORCE_Z,0) = 0.000000; -NODES[255](BODY_FORCE_X,0) = 0.000000; -NODES[255](BODY_FORCE_Y,0) = -9.810000; -NODES[255](BODY_FORCE_Z,0) = 0.000000; -NODES[256](BODY_FORCE_X,0) = 0.000000; -NODES[256](BODY_FORCE_Y,0) = -9.810000; -NODES[256](BODY_FORCE_Z,0) = 0.000000; -NODES[257](BODY_FORCE_X,0) = 0.000000; -NODES[257](BODY_FORCE_Y,0) = -9.810000; -NODES[257](BODY_FORCE_Z,0) = 0.000000; -NODES[258](BODY_FORCE_X,0) = 0.000000; -NODES[258](BODY_FORCE_Y,0) = -9.810000; -NODES[258](BODY_FORCE_Z,0) = 0.000000; -NODES[259](BODY_FORCE_X,0) = 0.000000; -NODES[259](BODY_FORCE_Y,0) = -9.810000; -NODES[259](BODY_FORCE_Z,0) = 0.000000; -NODES[260](BODY_FORCE_X,0) = 0.000000; -NODES[260](BODY_FORCE_Y,0) = -9.810000; -NODES[260](BODY_FORCE_Z,0) = 0.000000; -NODES[262](BODY_FORCE_X,0) = 0.000000; -NODES[262](BODY_FORCE_Y,0) = -9.810000; -NODES[262](BODY_FORCE_Z,0) = 0.000000; -NODES[263](BODY_FORCE_X,0) = 0.000000; -NODES[263](BODY_FORCE_Y,0) = -9.810000; -NODES[263](BODY_FORCE_Z,0) = 0.000000; -NODES[264](BODY_FORCE_X,0) = 0.000000; -NODES[264](BODY_FORCE_Y,0) = -9.810000; -NODES[264](BODY_FORCE_Z,0) = 0.000000; -NODES[265](BODY_FORCE_X,0) = 0.000000; -NODES[265](BODY_FORCE_Y,0) = -9.810000; -NODES[265](BODY_FORCE_Z,0) = 0.000000; -NODES[266](BODY_FORCE_X,0) = 0.000000; -NODES[266](BODY_FORCE_Y,0) = -9.810000; -NODES[266](BODY_FORCE_Z,0) = 0.000000; -NODES[267](BODY_FORCE_X,0) = 0.000000; -NODES[267](BODY_FORCE_Y,0) = -9.810000; -NODES[267](BODY_FORCE_Z,0) = 0.000000; -NODES[268](BODY_FORCE_X,0) = 0.000000; -NODES[268](BODY_FORCE_Y,0) = -9.810000; -NODES[268](BODY_FORCE_Z,0) = 0.000000; -NODES[269](BODY_FORCE_X,0) = 0.000000; -NODES[269](BODY_FORCE_Y,0) = -9.810000; -NODES[269](BODY_FORCE_Z,0) = 0.000000; -NODES[270](BODY_FORCE_X,0) = 0.000000; -NODES[270](BODY_FORCE_Y,0) = -9.810000; -NODES[270](BODY_FORCE_Z,0) = 0.000000; -NODES[271](BODY_FORCE_X,0) = 0.000000; -NODES[271](BODY_FORCE_Y,0) = -9.810000; -NODES[271](BODY_FORCE_Z,0) = 0.000000; -NODES[272](BODY_FORCE_X,0) = 0.000000; -NODES[272](BODY_FORCE_Y,0) = -9.810000; -NODES[272](BODY_FORCE_Z,0) = 0.000000; -NODES[273](BODY_FORCE_X,0) = 0.000000; -NODES[273](BODY_FORCE_Y,0) = -9.810000; -NODES[273](BODY_FORCE_Z,0) = 0.000000; -NODES[274](BODY_FORCE_X,0) = 0.000000; -NODES[274](BODY_FORCE_Y,0) = -9.810000; -NODES[274](BODY_FORCE_Z,0) = 0.000000; -NODES[275](BODY_FORCE_X,0) = 0.000000; -NODES[275](BODY_FORCE_Y,0) = -9.810000; -NODES[275](BODY_FORCE_Z,0) = 0.000000; -NODES[276](BODY_FORCE_X,0) = 0.000000; -NODES[276](BODY_FORCE_Y,0) = -9.810000; -NODES[276](BODY_FORCE_Z,0) = 0.000000; -NODES[277](BODY_FORCE_X,0) = 0.000000; -NODES[277](BODY_FORCE_Y,0) = -9.810000; -NODES[277](BODY_FORCE_Z,0) = 0.000000; -NODES[278](BODY_FORCE_X,0) = 0.000000; -NODES[278](BODY_FORCE_Y,0) = -9.810000; -NODES[278](BODY_FORCE_Z,0) = 0.000000; -NODES[279](BODY_FORCE_X,0) = 0.000000; -NODES[279](BODY_FORCE_Y,0) = -9.810000; -NODES[279](BODY_FORCE_Z,0) = 0.000000; -NODES[280](BODY_FORCE_X,0) = 0.000000; -NODES[280](BODY_FORCE_Y,0) = -9.810000; -NODES[280](BODY_FORCE_Z,0) = 0.000000; -NODES[281](BODY_FORCE_X,0) = 0.000000; -NODES[281](BODY_FORCE_Y,0) = -9.810000; -NODES[281](BODY_FORCE_Z,0) = 0.000000; -NODES[282](BODY_FORCE_X,0) = 0.000000; -NODES[282](BODY_FORCE_Y,0) = -9.810000; -NODES[282](BODY_FORCE_Z,0) = 0.000000; -NODES[283](BODY_FORCE_X,0) = 0.000000; -NODES[283](BODY_FORCE_Y,0) = -9.810000; -NODES[283](BODY_FORCE_Z,0) = 0.000000; -NODES[284](BODY_FORCE_X,0) = 0.000000; -NODES[284](BODY_FORCE_Y,0) = -9.810000; -NODES[284](BODY_FORCE_Z,0) = 0.000000; -NODES[285](BODY_FORCE_X,0) = 0.000000; -NODES[285](BODY_FORCE_Y,0) = -9.810000; -NODES[285](BODY_FORCE_Z,0) = 0.000000; -NODES[286](BODY_FORCE_X,0) = 0.000000; -NODES[286](BODY_FORCE_Y,0) = -9.810000; -NODES[286](BODY_FORCE_Z,0) = 0.000000; -NODES[287](BODY_FORCE_X,0) = 0.000000; -NODES[287](BODY_FORCE_Y,0) = -9.810000; -NODES[287](BODY_FORCE_Z,0) = 0.000000; -NODES[288](BODY_FORCE_X,0) = 0.000000; -NODES[288](BODY_FORCE_Y,0) = -9.810000; -NODES[288](BODY_FORCE_Z,0) = 0.000000; -NODES[289](BODY_FORCE_X,0) = 0.000000; -NODES[289](BODY_FORCE_Y,0) = -9.810000; -NODES[289](BODY_FORCE_Z,0) = 0.000000; -NODES[290](BODY_FORCE_X,0) = 0.000000; -NODES[290](BODY_FORCE_Y,0) = -9.810000; -NODES[290](BODY_FORCE_Z,0) = 0.000000; -NODES[291](BODY_FORCE_X,0) = 0.000000; -NODES[291](BODY_FORCE_Y,0) = -9.810000; -NODES[291](BODY_FORCE_Z,0) = 0.000000; -NODES[292](BODY_FORCE_X,0) = 0.000000; -NODES[292](BODY_FORCE_Y,0) = -9.810000; -NODES[292](BODY_FORCE_Z,0) = 0.000000; -NODES[293](BODY_FORCE_X,0) = 0.000000; -NODES[293](BODY_FORCE_Y,0) = -9.810000; -NODES[293](BODY_FORCE_Z,0) = 0.000000; -NODES[294](BODY_FORCE_X,0) = 0.000000; -NODES[294](BODY_FORCE_Y,0) = -9.810000; -NODES[294](BODY_FORCE_Z,0) = 0.000000; -NODES[295](BODY_FORCE_X,0) = 0.000000; -NODES[295](BODY_FORCE_Y,0) = -9.810000; -NODES[295](BODY_FORCE_Z,0) = 0.000000; -NODES[296](BODY_FORCE_X,0) = 0.000000; -NODES[296](BODY_FORCE_Y,0) = -9.810000; -NODES[296](BODY_FORCE_Z,0) = 0.000000; -NODES[297](BODY_FORCE_X,0) = 0.000000; -NODES[297](BODY_FORCE_Y,0) = -9.810000; -NODES[297](BODY_FORCE_Z,0) = 0.000000; -NODES[298](BODY_FORCE_X,0) = 0.000000; -NODES[298](BODY_FORCE_Y,0) = -9.810000; -NODES[298](BODY_FORCE_Z,0) = 0.000000; -NODES[300](BODY_FORCE_X,0) = 0.000000; -NODES[300](BODY_FORCE_Y,0) = -9.810000; -NODES[300](BODY_FORCE_Z,0) = 0.000000; -NODES[301](BODY_FORCE_X,0) = 0.000000; -NODES[301](BODY_FORCE_Y,0) = -9.810000; -NODES[301](BODY_FORCE_Z,0) = 0.000000; -NODES[302](BODY_FORCE_X,0) = 0.000000; -NODES[302](BODY_FORCE_Y,0) = -9.810000; -NODES[302](BODY_FORCE_Z,0) = 0.000000; -NODES[303](BODY_FORCE_X,0) = 0.000000; -NODES[303](BODY_FORCE_Y,0) = -9.810000; -NODES[303](BODY_FORCE_Z,0) = 0.000000; -NODES[304](BODY_FORCE_X,0) = 0.000000; -NODES[304](BODY_FORCE_Y,0) = -9.810000; -NODES[304](BODY_FORCE_Z,0) = 0.000000; -NODES[305](BODY_FORCE_X,0) = 0.000000; -NODES[305](BODY_FORCE_Y,0) = -9.810000; -NODES[305](BODY_FORCE_Z,0) = 0.000000; -NODES[306](BODY_FORCE_X,0) = 0.000000; -NODES[306](BODY_FORCE_Y,0) = -9.810000; -NODES[306](BODY_FORCE_Z,0) = 0.000000; -NODES[307](BODY_FORCE_X,0) = 0.000000; -NODES[307](BODY_FORCE_Y,0) = -9.810000; -NODES[307](BODY_FORCE_Z,0) = 0.000000; -NODES[308](BODY_FORCE_X,0) = 0.000000; -NODES[308](BODY_FORCE_Y,0) = -9.810000; -NODES[308](BODY_FORCE_Z,0) = 0.000000; -NODES[309](BODY_FORCE_X,0) = 0.000000; -NODES[309](BODY_FORCE_Y,0) = -9.810000; -NODES[309](BODY_FORCE_Z,0) = 0.000000; -NODES[310](BODY_FORCE_X,0) = 0.000000; -NODES[310](BODY_FORCE_Y,0) = -9.810000; -NODES[310](BODY_FORCE_Z,0) = 0.000000; -NODES[311](BODY_FORCE_X,0) = 0.000000; -NODES[311](BODY_FORCE_Y,0) = -9.810000; -NODES[311](BODY_FORCE_Z,0) = 0.000000; -NODES[312](BODY_FORCE_X,0) = 0.000000; -NODES[312](BODY_FORCE_Y,0) = -9.810000; -NODES[312](BODY_FORCE_Z,0) = 0.000000; -NODES[313](BODY_FORCE_X,0) = 0.000000; -NODES[313](BODY_FORCE_Y,0) = -9.810000; -NODES[313](BODY_FORCE_Z,0) = 0.000000; -NODES[314](BODY_FORCE_X,0) = 0.000000; -NODES[314](BODY_FORCE_Y,0) = -9.810000; -NODES[314](BODY_FORCE_Z,0) = 0.000000; -NODES[315](BODY_FORCE_X,0) = 0.000000; -NODES[315](BODY_FORCE_Y,0) = -9.810000; -NODES[315](BODY_FORCE_Z,0) = 0.000000; -NODES[316](BODY_FORCE_X,0) = 0.000000; -NODES[316](BODY_FORCE_Y,0) = -9.810000; -NODES[316](BODY_FORCE_Z,0) = 0.000000; -NODES[317](BODY_FORCE_X,0) = 0.000000; -NODES[317](BODY_FORCE_Y,0) = -9.810000; -NODES[317](BODY_FORCE_Z,0) = 0.000000; -NODES[318](BODY_FORCE_X,0) = 0.000000; -NODES[318](BODY_FORCE_Y,0) = -9.810000; -NODES[318](BODY_FORCE_Z,0) = 0.000000; -NODES[319](BODY_FORCE_X,0) = 0.000000; -NODES[319](BODY_FORCE_Y,0) = -9.810000; -NODES[319](BODY_FORCE_Z,0) = 0.000000; -NODES[320](BODY_FORCE_X,0) = 0.000000; -NODES[320](BODY_FORCE_Y,0) = -9.810000; -NODES[320](BODY_FORCE_Z,0) = 0.000000; -NODES[321](BODY_FORCE_X,0) = 0.000000; -NODES[321](BODY_FORCE_Y,0) = -9.810000; -NODES[321](BODY_FORCE_Z,0) = 0.000000; -NODES[322](BODY_FORCE_X,0) = 0.000000; -NODES[322](BODY_FORCE_Y,0) = -9.810000; -NODES[322](BODY_FORCE_Z,0) = 0.000000; -NODES[323](BODY_FORCE_X,0) = 0.000000; -NODES[323](BODY_FORCE_Y,0) = -9.810000; -NODES[323](BODY_FORCE_Z,0) = 0.000000; -NODES[324](BODY_FORCE_X,0) = 0.000000; -NODES[324](BODY_FORCE_Y,0) = -9.810000; -NODES[324](BODY_FORCE_Z,0) = 0.000000; -NODES[325](BODY_FORCE_X,0) = 0.000000; -NODES[325](BODY_FORCE_Y,0) = -9.810000; -NODES[325](BODY_FORCE_Z,0) = 0.000000; -NODES[326](BODY_FORCE_X,0) = 0.000000; -NODES[326](BODY_FORCE_Y,0) = -9.810000; -NODES[326](BODY_FORCE_Z,0) = 0.000000; -NODES[327](BODY_FORCE_X,0) = 0.000000; -NODES[327](BODY_FORCE_Y,0) = -9.810000; -NODES[327](BODY_FORCE_Z,0) = 0.000000; -NODES[328](BODY_FORCE_X,0) = 0.000000; -NODES[328](BODY_FORCE_Y,0) = -9.810000; -NODES[328](BODY_FORCE_Z,0) = 0.000000; -NODES[329](BODY_FORCE_X,0) = 0.000000; -NODES[329](BODY_FORCE_Y,0) = -9.810000; -NODES[329](BODY_FORCE_Z,0) = 0.000000; -NODES[330](BODY_FORCE_X,0) = 0.000000; -NODES[330](BODY_FORCE_Y,0) = -9.810000; -NODES[330](BODY_FORCE_Z,0) = 0.000000; -NODES[331](BODY_FORCE_X,0) = 0.000000; -NODES[331](BODY_FORCE_Y,0) = -9.810000; -NODES[331](BODY_FORCE_Z,0) = 0.000000; -NODES[332](BODY_FORCE_X,0) = 0.000000; -NODES[332](BODY_FORCE_Y,0) = -9.810000; -NODES[332](BODY_FORCE_Z,0) = 0.000000; -NODES[333](BODY_FORCE_X,0) = 0.000000; -NODES[333](BODY_FORCE_Y,0) = -9.810000; -NODES[333](BODY_FORCE_Z,0) = 0.000000; -NODES[334](BODY_FORCE_X,0) = 0.000000; -NODES[334](BODY_FORCE_Y,0) = -9.810000; -NODES[334](BODY_FORCE_Z,0) = 0.000000; -NODES[335](BODY_FORCE_X,0) = 0.000000; -NODES[335](BODY_FORCE_Y,0) = -9.810000; -NODES[335](BODY_FORCE_Z,0) = 0.000000; -NODES[336](BODY_FORCE_X,0) = 0.000000; -NODES[336](BODY_FORCE_Y,0) = -9.810000; -NODES[336](BODY_FORCE_Z,0) = 0.000000; -NODES[338](BODY_FORCE_X,0) = 0.000000; -NODES[338](BODY_FORCE_Y,0) = -9.810000; -NODES[338](BODY_FORCE_Z,0) = 0.000000; -NODES[339](BODY_FORCE_X,0) = 0.000000; -NODES[339](BODY_FORCE_Y,0) = -9.810000; -NODES[339](BODY_FORCE_Z,0) = 0.000000; -NODES[340](BODY_FORCE_X,0) = 0.000000; -NODES[340](BODY_FORCE_Y,0) = -9.810000; -NODES[340](BODY_FORCE_Z,0) = 0.000000; -NODES[341](BODY_FORCE_X,0) = 0.000000; -NODES[341](BODY_FORCE_Y,0) = -9.810000; -NODES[341](BODY_FORCE_Z,0) = 0.000000; -NODES[342](BODY_FORCE_X,0) = 0.000000; -NODES[342](BODY_FORCE_Y,0) = -9.810000; -NODES[342](BODY_FORCE_Z,0) = 0.000000; -NODES[343](BODY_FORCE_X,0) = 0.000000; -NODES[343](BODY_FORCE_Y,0) = -9.810000; -NODES[343](BODY_FORCE_Z,0) = 0.000000; -NODES[344](BODY_FORCE_X,0) = 0.000000; -NODES[344](BODY_FORCE_Y,0) = -9.810000; -NODES[344](BODY_FORCE_Z,0) = 0.000000; -NODES[345](BODY_FORCE_X,0) = 0.000000; -NODES[345](BODY_FORCE_Y,0) = -9.810000; -NODES[345](BODY_FORCE_Z,0) = 0.000000; -NODES[346](BODY_FORCE_X,0) = 0.000000; -NODES[346](BODY_FORCE_Y,0) = -9.810000; -NODES[346](BODY_FORCE_Z,0) = 0.000000; -NODES[347](BODY_FORCE_X,0) = 0.000000; -NODES[347](BODY_FORCE_Y,0) = -9.810000; -NODES[347](BODY_FORCE_Z,0) = 0.000000; -NODES[348](BODY_FORCE_X,0) = 0.000000; -NODES[348](BODY_FORCE_Y,0) = -9.810000; -NODES[348](BODY_FORCE_Z,0) = 0.000000; -NODES[349](BODY_FORCE_X,0) = 0.000000; -NODES[349](BODY_FORCE_Y,0) = -9.810000; -NODES[349](BODY_FORCE_Z,0) = 0.000000; -NODES[350](BODY_FORCE_X,0) = 0.000000; -NODES[350](BODY_FORCE_Y,0) = -9.810000; -NODES[350](BODY_FORCE_Z,0) = 0.000000; -NODES[351](BODY_FORCE_X,0) = 0.000000; -NODES[351](BODY_FORCE_Y,0) = -9.810000; -NODES[351](BODY_FORCE_Z,0) = 0.000000; -NODES[352](BODY_FORCE_X,0) = 0.000000; -NODES[352](BODY_FORCE_Y,0) = -9.810000; -NODES[352](BODY_FORCE_Z,0) = 0.000000; -NODES[353](BODY_FORCE_X,0) = 0.000000; -NODES[353](BODY_FORCE_Y,0) = -9.810000; -NODES[353](BODY_FORCE_Z,0) = 0.000000; -NODES[354](BODY_FORCE_X,0) = 0.000000; -NODES[354](BODY_FORCE_Y,0) = -9.810000; -NODES[354](BODY_FORCE_Z,0) = 0.000000; -NODES[355](BODY_FORCE_X,0) = 0.000000; -NODES[355](BODY_FORCE_Y,0) = -9.810000; -NODES[355](BODY_FORCE_Z,0) = 0.000000; -NODES[356](BODY_FORCE_X,0) = 0.000000; -NODES[356](BODY_FORCE_Y,0) = -9.810000; -NODES[356](BODY_FORCE_Z,0) = 0.000000; -NODES[357](BODY_FORCE_X,0) = 0.000000; -NODES[357](BODY_FORCE_Y,0) = -9.810000; -NODES[357](BODY_FORCE_Z,0) = 0.000000; -NODES[358](BODY_FORCE_X,0) = 0.000000; -NODES[358](BODY_FORCE_Y,0) = -9.810000; -NODES[358](BODY_FORCE_Z,0) = 0.000000; -NODES[359](BODY_FORCE_X,0) = 0.000000; -NODES[359](BODY_FORCE_Y,0) = -9.810000; -NODES[359](BODY_FORCE_Z,0) = 0.000000; -NODES[360](BODY_FORCE_X,0) = 0.000000; -NODES[360](BODY_FORCE_Y,0) = -9.810000; -NODES[360](BODY_FORCE_Z,0) = 0.000000; -NODES[361](BODY_FORCE_X,0) = 0.000000; -NODES[361](BODY_FORCE_Y,0) = -9.810000; -NODES[361](BODY_FORCE_Z,0) = 0.000000; -NODES[362](BODY_FORCE_X,0) = 0.000000; -NODES[362](BODY_FORCE_Y,0) = -9.810000; -NODES[362](BODY_FORCE_Z,0) = 0.000000; -NODES[363](BODY_FORCE_X,0) = 0.000000; -NODES[363](BODY_FORCE_Y,0) = -9.810000; -NODES[363](BODY_FORCE_Z,0) = 0.000000; -NODES[364](BODY_FORCE_X,0) = 0.000000; -NODES[364](BODY_FORCE_Y,0) = -9.810000; -NODES[364](BODY_FORCE_Z,0) = 0.000000; -NODES[365](BODY_FORCE_X,0) = 0.000000; -NODES[365](BODY_FORCE_Y,0) = -9.810000; -NODES[365](BODY_FORCE_Z,0) = 0.000000; -NODES[366](BODY_FORCE_X,0) = 0.000000; -NODES[366](BODY_FORCE_Y,0) = -9.810000; -NODES[366](BODY_FORCE_Z,0) = 0.000000; -NODES[367](BODY_FORCE_X,0) = 0.000000; -NODES[367](BODY_FORCE_Y,0) = -9.810000; -NODES[367](BODY_FORCE_Z,0) = 0.000000; -NODES[368](BODY_FORCE_X,0) = 0.000000; -NODES[368](BODY_FORCE_Y,0) = -9.810000; -NODES[368](BODY_FORCE_Z,0) = 0.000000; -NODES[369](BODY_FORCE_X,0) = 0.000000; -NODES[369](BODY_FORCE_Y,0) = -9.810000; -NODES[369](BODY_FORCE_Z,0) = 0.000000; -NODES[370](BODY_FORCE_X,0) = 0.000000; -NODES[370](BODY_FORCE_Y,0) = -9.810000; -NODES[370](BODY_FORCE_Z,0) = 0.000000; -NODES[371](BODY_FORCE_X,0) = 0.000000; -NODES[371](BODY_FORCE_Y,0) = -9.810000; -NODES[371](BODY_FORCE_Z,0) = 0.000000; -NODES[372](BODY_FORCE_X,0) = 0.000000; -NODES[372](BODY_FORCE_Y,0) = -9.810000; -NODES[372](BODY_FORCE_Z,0) = 0.000000; -NODES[373](BODY_FORCE_X,0) = 0.000000; -NODES[373](BODY_FORCE_Y,0) = -9.810000; -NODES[373](BODY_FORCE_Z,0) = 0.000000; -NODES[374](BODY_FORCE_X,0) = 0.000000; -NODES[374](BODY_FORCE_Y,0) = -9.810000; -NODES[374](BODY_FORCE_Z,0) = 0.000000; -NODES[375](BODY_FORCE_X,0) = 0.000000; -NODES[375](BODY_FORCE_Y,0) = -9.810000; -NODES[375](BODY_FORCE_Z,0) = 0.000000; -NODES[376](BODY_FORCE_X,0) = 0.000000; -NODES[376](BODY_FORCE_Y,0) = -9.810000; -NODES[376](BODY_FORCE_Z,0) = 0.000000; -NODES[377](BODY_FORCE_X,0) = 0.000000; -NODES[377](BODY_FORCE_Y,0) = -9.810000; -NODES[377](BODY_FORCE_Z,0) = 0.000000; -NODES[378](BODY_FORCE_X,0) = 0.000000; -NODES[378](BODY_FORCE_Y,0) = -9.810000; -NODES[378](BODY_FORCE_Z,0) = 0.000000; -NODES[379](BODY_FORCE_X,0) = 0.000000; -NODES[379](BODY_FORCE_Y,0) = -9.810000; -NODES[379](BODY_FORCE_Z,0) = 0.000000; -NODES[380](BODY_FORCE_X,0) = 0.000000; -NODES[380](BODY_FORCE_Y,0) = -9.810000; -NODES[380](BODY_FORCE_Z,0) = 0.000000; -NODES[382](BODY_FORCE_X,0) = 0.000000; -NODES[382](BODY_FORCE_Y,0) = -9.810000; -NODES[382](BODY_FORCE_Z,0) = 0.000000; -NODES[383](BODY_FORCE_X,0) = 0.000000; -NODES[383](BODY_FORCE_Y,0) = -9.810000; -NODES[383](BODY_FORCE_Z,0) = 0.000000; -NODES[384](BODY_FORCE_X,0) = 0.000000; -NODES[384](BODY_FORCE_Y,0) = -9.810000; -NODES[384](BODY_FORCE_Z,0) = 0.000000; -NODES[385](BODY_FORCE_X,0) = 0.000000; -NODES[385](BODY_FORCE_Y,0) = -9.810000; -NODES[385](BODY_FORCE_Z,0) = 0.000000; -NODES[386](BODY_FORCE_X,0) = 0.000000; -NODES[386](BODY_FORCE_Y,0) = -9.810000; -NODES[386](BODY_FORCE_Z,0) = 0.000000; -NODES[387](BODY_FORCE_X,0) = 0.000000; -NODES[387](BODY_FORCE_Y,0) = -9.810000; -NODES[387](BODY_FORCE_Z,0) = 0.000000; -NODES[388](BODY_FORCE_X,0) = 0.000000; -NODES[388](BODY_FORCE_Y,0) = -9.810000; -NODES[388](BODY_FORCE_Z,0) = 0.000000; -NODES[389](BODY_FORCE_X,0) = 0.000000; -NODES[389](BODY_FORCE_Y,0) = -9.810000; -NODES[389](BODY_FORCE_Z,0) = 0.000000; -NODES[390](BODY_FORCE_X,0) = 0.000000; -NODES[390](BODY_FORCE_Y,0) = -9.810000; -NODES[390](BODY_FORCE_Z,0) = 0.000000; -NODES[391](BODY_FORCE_X,0) = 0.000000; -NODES[391](BODY_FORCE_Y,0) = -9.810000; -NODES[391](BODY_FORCE_Z,0) = 0.000000; -NODES[392](BODY_FORCE_X,0) = 0.000000; -NODES[392](BODY_FORCE_Y,0) = -9.810000; -NODES[392](BODY_FORCE_Z,0) = 0.000000; -NODES[393](BODY_FORCE_X,0) = 0.000000; -NODES[393](BODY_FORCE_Y,0) = -9.810000; -NODES[393](BODY_FORCE_Z,0) = 0.000000; -NODES[394](BODY_FORCE_X,0) = 0.000000; -NODES[394](BODY_FORCE_Y,0) = -9.810000; -NODES[394](BODY_FORCE_Z,0) = 0.000000; -NODES[395](BODY_FORCE_X,0) = 0.000000; -NODES[395](BODY_FORCE_Y,0) = -9.810000; -NODES[395](BODY_FORCE_Z,0) = 0.000000; -NODES[396](BODY_FORCE_X,0) = 0.000000; -NODES[396](BODY_FORCE_Y,0) = -9.810000; -NODES[396](BODY_FORCE_Z,0) = 0.000000; -NODES[397](BODY_FORCE_X,0) = 0.000000; -NODES[397](BODY_FORCE_Y,0) = -9.810000; -NODES[397](BODY_FORCE_Z,0) = 0.000000; -NODES[398](BODY_FORCE_X,0) = 0.000000; -NODES[398](BODY_FORCE_Y,0) = -9.810000; -NODES[398](BODY_FORCE_Z,0) = 0.000000; -NODES[399](BODY_FORCE_X,0) = 0.000000; -NODES[399](BODY_FORCE_Y,0) = -9.810000; -NODES[399](BODY_FORCE_Z,0) = 0.000000; -NODES[400](BODY_FORCE_X,0) = 0.000000; -NODES[400](BODY_FORCE_Y,0) = -9.810000; -NODES[400](BODY_FORCE_Z,0) = 0.000000; -NODES[401](BODY_FORCE_X,0) = 0.000000; -NODES[401](BODY_FORCE_Y,0) = -9.810000; -NODES[401](BODY_FORCE_Z,0) = 0.000000; -NODES[402](BODY_FORCE_X,0) = 0.000000; -NODES[402](BODY_FORCE_Y,0) = -9.810000; -NODES[402](BODY_FORCE_Z,0) = 0.000000; -NODES[403](BODY_FORCE_X,0) = 0.000000; -NODES[403](BODY_FORCE_Y,0) = -9.810000; -NODES[403](BODY_FORCE_Z,0) = 0.000000; -NODES[404](BODY_FORCE_X,0) = 0.000000; -NODES[404](BODY_FORCE_Y,0) = -9.810000; -NODES[404](BODY_FORCE_Z,0) = 0.000000; -NODES[405](BODY_FORCE_X,0) = 0.000000; -NODES[405](BODY_FORCE_Y,0) = -9.810000; -NODES[405](BODY_FORCE_Z,0) = 0.000000; -NODES[406](BODY_FORCE_X,0) = 0.000000; -NODES[406](BODY_FORCE_Y,0) = -9.810000; -NODES[406](BODY_FORCE_Z,0) = 0.000000; -NODES[407](BODY_FORCE_X,0) = 0.000000; -NODES[407](BODY_FORCE_Y,0) = -9.810000; -NODES[407](BODY_FORCE_Z,0) = 0.000000; -NODES[408](BODY_FORCE_X,0) = 0.000000; -NODES[408](BODY_FORCE_Y,0) = -9.810000; -NODES[408](BODY_FORCE_Z,0) = 0.000000; -NODES[409](BODY_FORCE_X,0) = 0.000000; -NODES[409](BODY_FORCE_Y,0) = -9.810000; -NODES[409](BODY_FORCE_Z,0) = 0.000000; -NODES[410](BODY_FORCE_X,0) = 0.000000; -NODES[410](BODY_FORCE_Y,0) = -9.810000; -NODES[410](BODY_FORCE_Z,0) = 0.000000; -NODES[411](BODY_FORCE_X,0) = 0.000000; -NODES[411](BODY_FORCE_Y,0) = -9.810000; -NODES[411](BODY_FORCE_Z,0) = 0.000000; -NODES[412](BODY_FORCE_X,0) = 0.000000; -NODES[412](BODY_FORCE_Y,0) = -9.810000; -NODES[412](BODY_FORCE_Z,0) = 0.000000; -NODES[413](BODY_FORCE_X,0) = 0.000000; -NODES[413](BODY_FORCE_Y,0) = -9.810000; -NODES[413](BODY_FORCE_Z,0) = 0.000000; -NODES[414](BODY_FORCE_X,0) = 0.000000; -NODES[414](BODY_FORCE_Y,0) = -9.810000; -NODES[414](BODY_FORCE_Z,0) = 0.000000; -NODES[415](BODY_FORCE_X,0) = 0.000000; -NODES[415](BODY_FORCE_Y,0) = -9.810000; -NODES[415](BODY_FORCE_Z,0) = 0.000000; -NODES[416](BODY_FORCE_X,0) = 0.000000; -NODES[416](BODY_FORCE_Y,0) = -9.810000; -NODES[416](BODY_FORCE_Z,0) = 0.000000; -NODES[417](BODY_FORCE_X,0) = 0.000000; -NODES[417](BODY_FORCE_Y,0) = -9.810000; -NODES[417](BODY_FORCE_Z,0) = 0.000000; -NODES[418](BODY_FORCE_X,0) = 0.000000; -NODES[418](BODY_FORCE_Y,0) = -9.810000; -NODES[418](BODY_FORCE_Z,0) = 0.000000; -NODES[419](BODY_FORCE_X,0) = 0.000000; -NODES[419](BODY_FORCE_Y,0) = -9.810000; -NODES[419](BODY_FORCE_Z,0) = 0.000000; -NODES[420](BODY_FORCE_X,0) = 0.000000; -NODES[420](BODY_FORCE_Y,0) = -9.810000; -NODES[420](BODY_FORCE_Z,0) = 0.000000; -NODES[421](BODY_FORCE_X,0) = 0.000000; -NODES[421](BODY_FORCE_Y,0) = -9.810000; -NODES[421](BODY_FORCE_Z,0) = 0.000000; -NODES[422](BODY_FORCE_X,0) = 0.000000; -NODES[422](BODY_FORCE_Y,0) = -9.810000; -NODES[422](BODY_FORCE_Z,0) = 0.000000; -NODES[423](BODY_FORCE_X,0) = 0.000000; -NODES[423](BODY_FORCE_Y,0) = -9.810000; -NODES[423](BODY_FORCE_Z,0) = 0.000000; -NODES[424](BODY_FORCE_X,0) = 0.000000; -NODES[424](BODY_FORCE_Y,0) = -9.810000; -NODES[424](BODY_FORCE_Z,0) = 0.000000; -NODES[426](BODY_FORCE_X,0) = 0.000000; -NODES[426](BODY_FORCE_Y,0) = -9.810000; -NODES[426](BODY_FORCE_Z,0) = 0.000000; -NODES[427](BODY_FORCE_X,0) = 0.000000; -NODES[427](BODY_FORCE_Y,0) = -9.810000; -NODES[427](BODY_FORCE_Z,0) = 0.000000; -NODES[428](BODY_FORCE_X,0) = 0.000000; -NODES[428](BODY_FORCE_Y,0) = -9.810000; -NODES[428](BODY_FORCE_Z,0) = 0.000000; -NODES[429](BODY_FORCE_X,0) = 0.000000; -NODES[429](BODY_FORCE_Y,0) = -9.810000; -NODES[429](BODY_FORCE_Z,0) = 0.000000; -NODES[430](BODY_FORCE_X,0) = 0.000000; -NODES[430](BODY_FORCE_Y,0) = -9.810000; -NODES[430](BODY_FORCE_Z,0) = 0.000000; -NODES[431](BODY_FORCE_X,0) = 0.000000; -NODES[431](BODY_FORCE_Y,0) = -9.810000; -NODES[431](BODY_FORCE_Z,0) = 0.000000; -NODES[432](BODY_FORCE_X,0) = 0.000000; -NODES[432](BODY_FORCE_Y,0) = -9.810000; -NODES[432](BODY_FORCE_Z,0) = 0.000000; -NODES[433](BODY_FORCE_X,0) = 0.000000; -NODES[433](BODY_FORCE_Y,0) = -9.810000; -NODES[433](BODY_FORCE_Z,0) = 0.000000; -NODES[434](BODY_FORCE_X,0) = 0.000000; -NODES[434](BODY_FORCE_Y,0) = -9.810000; -NODES[434](BODY_FORCE_Z,0) = 0.000000; -NODES[435](BODY_FORCE_X,0) = 0.000000; -NODES[435](BODY_FORCE_Y,0) = -9.810000; -NODES[435](BODY_FORCE_Z,0) = 0.000000; -NODES[436](BODY_FORCE_X,0) = 0.000000; -NODES[436](BODY_FORCE_Y,0) = -9.810000; -NODES[436](BODY_FORCE_Z,0) = 0.000000; -NODES[437](BODY_FORCE_X,0) = 0.000000; -NODES[437](BODY_FORCE_Y,0) = -9.810000; -NODES[437](BODY_FORCE_Z,0) = 0.000000; -NODES[438](BODY_FORCE_X,0) = 0.000000; -NODES[438](BODY_FORCE_Y,0) = -9.810000; -NODES[438](BODY_FORCE_Z,0) = 0.000000; -NODES[439](BODY_FORCE_X,0) = 0.000000; -NODES[439](BODY_FORCE_Y,0) = -9.810000; -NODES[439](BODY_FORCE_Z,0) = 0.000000; -NODES[440](BODY_FORCE_X,0) = 0.000000; -NODES[440](BODY_FORCE_Y,0) = -9.810000; -NODES[440](BODY_FORCE_Z,0) = 0.000000; -NODES[441](BODY_FORCE_X,0) = 0.000000; -NODES[441](BODY_FORCE_Y,0) = -9.810000; -NODES[441](BODY_FORCE_Z,0) = 0.000000; -NODES[442](BODY_FORCE_X,0) = 0.000000; -NODES[442](BODY_FORCE_Y,0) = -9.810000; -NODES[442](BODY_FORCE_Z,0) = 0.000000; -NODES[443](BODY_FORCE_X,0) = 0.000000; -NODES[443](BODY_FORCE_Y,0) = -9.810000; -NODES[443](BODY_FORCE_Z,0) = 0.000000; -NODES[444](BODY_FORCE_X,0) = 0.000000; -NODES[444](BODY_FORCE_Y,0) = -9.810000; -NODES[444](BODY_FORCE_Z,0) = 0.000000; -NODES[445](BODY_FORCE_X,0) = 0.000000; -NODES[445](BODY_FORCE_Y,0) = -9.810000; -NODES[445](BODY_FORCE_Z,0) = 0.000000; -NODES[446](BODY_FORCE_X,0) = 0.000000; -NODES[446](BODY_FORCE_Y,0) = -9.810000; -NODES[446](BODY_FORCE_Z,0) = 0.000000; -NODES[447](BODY_FORCE_X,0) = 0.000000; -NODES[447](BODY_FORCE_Y,0) = -9.810000; -NODES[447](BODY_FORCE_Z,0) = 0.000000; -NODES[448](BODY_FORCE_X,0) = 0.000000; -NODES[448](BODY_FORCE_Y,0) = -9.810000; -NODES[448](BODY_FORCE_Z,0) = 0.000000; -NODES[449](BODY_FORCE_X,0) = 0.000000; -NODES[449](BODY_FORCE_Y,0) = -9.810000; -NODES[449](BODY_FORCE_Z,0) = 0.000000; -NODES[450](BODY_FORCE_X,0) = 0.000000; -NODES[450](BODY_FORCE_Y,0) = -9.810000; -NODES[450](BODY_FORCE_Z,0) = 0.000000; -NODES[451](BODY_FORCE_X,0) = 0.000000; -NODES[451](BODY_FORCE_Y,0) = -9.810000; -NODES[451](BODY_FORCE_Z,0) = 0.000000; -NODES[452](BODY_FORCE_X,0) = 0.000000; -NODES[452](BODY_FORCE_Y,0) = -9.810000; -NODES[452](BODY_FORCE_Z,0) = 0.000000; -NODES[453](BODY_FORCE_X,0) = 0.000000; -NODES[453](BODY_FORCE_Y,0) = -9.810000; -NODES[453](BODY_FORCE_Z,0) = 0.000000; -NODES[454](BODY_FORCE_X,0) = 0.000000; -NODES[454](BODY_FORCE_Y,0) = -9.810000; -NODES[454](BODY_FORCE_Z,0) = 0.000000; -NODES[455](BODY_FORCE_X,0) = 0.000000; -NODES[455](BODY_FORCE_Y,0) = -9.810000; -NODES[455](BODY_FORCE_Z,0) = 0.000000; -NODES[456](BODY_FORCE_X,0) = 0.000000; -NODES[456](BODY_FORCE_Y,0) = -9.810000; -NODES[456](BODY_FORCE_Z,0) = 0.000000; -NODES[457](BODY_FORCE_X,0) = 0.000000; -NODES[457](BODY_FORCE_Y,0) = -9.810000; -NODES[457](BODY_FORCE_Z,0) = 0.000000; -NODES[458](BODY_FORCE_X,0) = 0.000000; -NODES[458](BODY_FORCE_Y,0) = -9.810000; -NODES[458](BODY_FORCE_Z,0) = 0.000000; -NODES[459](BODY_FORCE_X,0) = 0.000000; -NODES[459](BODY_FORCE_Y,0) = -9.810000; -NODES[459](BODY_FORCE_Z,0) = 0.000000; -NODES[460](BODY_FORCE_X,0) = 0.000000; -NODES[460](BODY_FORCE_Y,0) = -9.810000; -NODES[460](BODY_FORCE_Z,0) = 0.000000; -NODES[461](BODY_FORCE_X,0) = 0.000000; -NODES[461](BODY_FORCE_Y,0) = -9.810000; -NODES[461](BODY_FORCE_Z,0) = 0.000000; -NODES[462](BODY_FORCE_X,0) = 0.000000; -NODES[462](BODY_FORCE_Y,0) = -9.810000; -NODES[462](BODY_FORCE_Z,0) = 0.000000; -NODES[463](BODY_FORCE_X,0) = 0.000000; -NODES[463](BODY_FORCE_Y,0) = -9.810000; -NODES[463](BODY_FORCE_Z,0) = 0.000000; -NODES[464](BODY_FORCE_X,0) = 0.000000; -NODES[464](BODY_FORCE_Y,0) = -9.810000; -NODES[464](BODY_FORCE_Z,0) = 0.000000; -NODES[465](BODY_FORCE_X,0) = 0.000000; -NODES[465](BODY_FORCE_Y,0) = -9.810000; -NODES[465](BODY_FORCE_Z,0) = 0.000000; -NODES[466](BODY_FORCE_X,0) = 0.000000; -NODES[466](BODY_FORCE_Y,0) = -9.810000; -NODES[466](BODY_FORCE_Z,0) = 0.000000; -NODES[467](BODY_FORCE_X,0) = 0.000000; -NODES[467](BODY_FORCE_Y,0) = -9.810000; -NODES[467](BODY_FORCE_Z,0) = 0.000000; -NODES[468](BODY_FORCE_X,0) = 0.000000; -NODES[468](BODY_FORCE_Y,0) = -9.810000; -NODES[468](BODY_FORCE_Z,0) = 0.000000; -NODES[469](BODY_FORCE_X,0) = 0.000000; -NODES[469](BODY_FORCE_Y,0) = -9.810000; -NODES[469](BODY_FORCE_Z,0) = 0.000000; -NODES[471](BODY_FORCE_X,0) = 0.000000; -NODES[471](BODY_FORCE_Y,0) = -9.810000; -NODES[471](BODY_FORCE_Z,0) = 0.000000; -NODES[472](BODY_FORCE_X,0) = 0.000000; -NODES[472](BODY_FORCE_Y,0) = -9.810000; -NODES[472](BODY_FORCE_Z,0) = 0.000000; -NODES[473](BODY_FORCE_X,0) = 0.000000; -NODES[473](BODY_FORCE_Y,0) = -9.810000; -NODES[473](BODY_FORCE_Z,0) = 0.000000; -NODES[474](BODY_FORCE_X,0) = 0.000000; -NODES[474](BODY_FORCE_Y,0) = -9.810000; -NODES[474](BODY_FORCE_Z,0) = 0.000000; -NODES[475](BODY_FORCE_X,0) = 0.000000; -NODES[475](BODY_FORCE_Y,0) = -9.810000; -NODES[475](BODY_FORCE_Z,0) = 0.000000; -NODES[476](BODY_FORCE_X,0) = 0.000000; -NODES[476](BODY_FORCE_Y,0) = -9.810000; -NODES[476](BODY_FORCE_Z,0) = 0.000000; -NODES[477](BODY_FORCE_X,0) = 0.000000; -NODES[477](BODY_FORCE_Y,0) = -9.810000; -NODES[477](BODY_FORCE_Z,0) = 0.000000; -NODES[478](BODY_FORCE_X,0) = 0.000000; -NODES[478](BODY_FORCE_Y,0) = -9.810000; -NODES[478](BODY_FORCE_Z,0) = 0.000000; -NODES[479](BODY_FORCE_X,0) = 0.000000; -NODES[479](BODY_FORCE_Y,0) = -9.810000; -NODES[479](BODY_FORCE_Z,0) = 0.000000; -NODES[480](BODY_FORCE_X,0) = 0.000000; -NODES[480](BODY_FORCE_Y,0) = -9.810000; -NODES[480](BODY_FORCE_Z,0) = 0.000000; -NODES[481](BODY_FORCE_X,0) = 0.000000; -NODES[481](BODY_FORCE_Y,0) = -9.810000; -NODES[481](BODY_FORCE_Z,0) = 0.000000; -NODES[482](BODY_FORCE_X,0) = 0.000000; -NODES[482](BODY_FORCE_Y,0) = -9.810000; -NODES[482](BODY_FORCE_Z,0) = 0.000000; -NODES[483](BODY_FORCE_X,0) = 0.000000; -NODES[483](BODY_FORCE_Y,0) = -9.810000; -NODES[483](BODY_FORCE_Z,0) = 0.000000; -NODES[484](BODY_FORCE_X,0) = 0.000000; -NODES[484](BODY_FORCE_Y,0) = -9.810000; -NODES[484](BODY_FORCE_Z,0) = 0.000000; -NODES[485](BODY_FORCE_X,0) = 0.000000; -NODES[485](BODY_FORCE_Y,0) = -9.810000; -NODES[485](BODY_FORCE_Z,0) = 0.000000; -NODES[486](BODY_FORCE_X,0) = 0.000000; -NODES[486](BODY_FORCE_Y,0) = -9.810000; -NODES[486](BODY_FORCE_Z,0) = 0.000000; -NODES[487](BODY_FORCE_X,0) = 0.000000; -NODES[487](BODY_FORCE_Y,0) = -9.810000; -NODES[487](BODY_FORCE_Z,0) = 0.000000; -NODES[488](BODY_FORCE_X,0) = 0.000000; -NODES[488](BODY_FORCE_Y,0) = -9.810000; -NODES[488](BODY_FORCE_Z,0) = 0.000000; -NODES[489](BODY_FORCE_X,0) = 0.000000; -NODES[489](BODY_FORCE_Y,0) = -9.810000; -NODES[489](BODY_FORCE_Z,0) = 0.000000; -NODES[490](BODY_FORCE_X,0) = 0.000000; -NODES[490](BODY_FORCE_Y,0) = -9.810000; -NODES[490](BODY_FORCE_Z,0) = 0.000000; -NODES[491](BODY_FORCE_X,0) = 0.000000; -NODES[491](BODY_FORCE_Y,0) = -9.810000; -NODES[491](BODY_FORCE_Z,0) = 0.000000; -NODES[492](BODY_FORCE_X,0) = 0.000000; -NODES[492](BODY_FORCE_Y,0) = -9.810000; -NODES[492](BODY_FORCE_Z,0) = 0.000000; -NODES[493](BODY_FORCE_X,0) = 0.000000; -NODES[493](BODY_FORCE_Y,0) = -9.810000; -NODES[493](BODY_FORCE_Z,0) = 0.000000; -NODES[494](BODY_FORCE_X,0) = 0.000000; -NODES[494](BODY_FORCE_Y,0) = -9.810000; -NODES[494](BODY_FORCE_Z,0) = 0.000000; -NODES[495](BODY_FORCE_X,0) = 0.000000; -NODES[495](BODY_FORCE_Y,0) = -9.810000; -NODES[495](BODY_FORCE_Z,0) = 0.000000; -NODES[496](BODY_FORCE_X,0) = 0.000000; -NODES[496](BODY_FORCE_Y,0) = -9.810000; -NODES[496](BODY_FORCE_Z,0) = 0.000000; -NODES[497](BODY_FORCE_X,0) = 0.000000; -NODES[497](BODY_FORCE_Y,0) = -9.810000; -NODES[497](BODY_FORCE_Z,0) = 0.000000; -NODES[498](BODY_FORCE_X,0) = 0.000000; -NODES[498](BODY_FORCE_Y,0) = -9.810000; -NODES[498](BODY_FORCE_Z,0) = 0.000000; -NODES[499](BODY_FORCE_X,0) = 0.000000; -NODES[499](BODY_FORCE_Y,0) = -9.810000; -NODES[499](BODY_FORCE_Z,0) = 0.000000; -NODES[500](BODY_FORCE_X,0) = 0.000000; -NODES[500](BODY_FORCE_Y,0) = -9.810000; -NODES[500](BODY_FORCE_Z,0) = 0.000000; -NODES[501](BODY_FORCE_X,0) = 0.000000; -NODES[501](BODY_FORCE_Y,0) = -9.810000; -NODES[501](BODY_FORCE_Z,0) = 0.000000; -NODES[502](BODY_FORCE_X,0) = 0.000000; -NODES[502](BODY_FORCE_Y,0) = -9.810000; -NODES[502](BODY_FORCE_Z,0) = 0.000000; -NODES[503](BODY_FORCE_X,0) = 0.000000; -NODES[503](BODY_FORCE_Y,0) = -9.810000; -NODES[503](BODY_FORCE_Z,0) = 0.000000; -NODES[504](BODY_FORCE_X,0) = 0.000000; -NODES[504](BODY_FORCE_Y,0) = -9.810000; -NODES[504](BODY_FORCE_Z,0) = 0.000000; -NODES[505](BODY_FORCE_X,0) = 0.000000; -NODES[505](BODY_FORCE_Y,0) = -9.810000; -NODES[505](BODY_FORCE_Z,0) = 0.000000; -NODES[506](BODY_FORCE_X,0) = 0.000000; -NODES[506](BODY_FORCE_Y,0) = -9.810000; -NODES[506](BODY_FORCE_Z,0) = 0.000000; -NODES[507](BODY_FORCE_X,0) = 0.000000; -NODES[507](BODY_FORCE_Y,0) = -9.810000; -NODES[507](BODY_FORCE_Z,0) = 0.000000; -NODES[508](BODY_FORCE_X,0) = 0.000000; -NODES[508](BODY_FORCE_Y,0) = -9.810000; -NODES[508](BODY_FORCE_Z,0) = 0.000000; -NODES[509](BODY_FORCE_X,0) = 0.000000; -NODES[509](BODY_FORCE_Y,0) = -9.810000; -NODES[509](BODY_FORCE_Z,0) = 0.000000; -NODES[510](BODY_FORCE_X,0) = 0.000000; -NODES[510](BODY_FORCE_Y,0) = -9.810000; -NODES[510](BODY_FORCE_Z,0) = 0.000000; -NODES[511](BODY_FORCE_X,0) = 0.000000; -NODES[511](BODY_FORCE_Y,0) = -9.810000; -NODES[511](BODY_FORCE_Z,0) = 0.000000; -NODES[512](BODY_FORCE_X,0) = 0.000000; -NODES[512](BODY_FORCE_Y,0) = -9.810000; -NODES[512](BODY_FORCE_Z,0) = 0.000000; -NODES[513](BODY_FORCE_X,0) = 0.000000; -NODES[513](BODY_FORCE_Y,0) = -9.810000; -NODES[513](BODY_FORCE_Z,0) = 0.000000; -NODES[514](BODY_FORCE_X,0) = 0.000000; -NODES[514](BODY_FORCE_Y,0) = -9.810000; -NODES[514](BODY_FORCE_Z,0) = 0.000000; -NODES[515](BODY_FORCE_X,0) = 0.000000; -NODES[515](BODY_FORCE_Y,0) = -9.810000; -NODES[515](BODY_FORCE_Z,0) = 0.000000; -NODES[516](BODY_FORCE_X,0) = 0.000000; -NODES[516](BODY_FORCE_Y,0) = -9.810000; -NODES[516](BODY_FORCE_Z,0) = 0.000000; -NODES[517](BODY_FORCE_X,0) = 0.000000; -NODES[517](BODY_FORCE_Y,0) = -9.810000; -NODES[517](BODY_FORCE_Z,0) = 0.000000; -NODES[519](BODY_FORCE_X,0) = 0.000000; -NODES[519](BODY_FORCE_Y,0) = -9.810000; -NODES[519](BODY_FORCE_Z,0) = 0.000000; -NODES[520](BODY_FORCE_X,0) = 0.000000; -NODES[520](BODY_FORCE_Y,0) = -9.810000; -NODES[520](BODY_FORCE_Z,0) = 0.000000; -NODES[521](BODY_FORCE_X,0) = 0.000000; -NODES[521](BODY_FORCE_Y,0) = -9.810000; -NODES[521](BODY_FORCE_Z,0) = 0.000000; -NODES[522](BODY_FORCE_X,0) = 0.000000; -NODES[522](BODY_FORCE_Y,0) = -9.810000; -NODES[522](BODY_FORCE_Z,0) = 0.000000; -NODES[523](BODY_FORCE_X,0) = 0.000000; -NODES[523](BODY_FORCE_Y,0) = -9.810000; -NODES[523](BODY_FORCE_Z,0) = 0.000000; -NODES[524](BODY_FORCE_X,0) = 0.000000; -NODES[524](BODY_FORCE_Y,0) = -9.810000; -NODES[524](BODY_FORCE_Z,0) = 0.000000; -NODES[525](BODY_FORCE_X,0) = 0.000000; -NODES[525](BODY_FORCE_Y,0) = -9.810000; -NODES[525](BODY_FORCE_Z,0) = 0.000000; -NODES[526](BODY_FORCE_X,0) = 0.000000; -NODES[526](BODY_FORCE_Y,0) = -9.810000; -NODES[526](BODY_FORCE_Z,0) = 0.000000; -NODES[527](BODY_FORCE_X,0) = 0.000000; -NODES[527](BODY_FORCE_Y,0) = -9.810000; -NODES[527](BODY_FORCE_Z,0) = 0.000000; -NODES[528](BODY_FORCE_X,0) = 0.000000; -NODES[528](BODY_FORCE_Y,0) = -9.810000; -NODES[528](BODY_FORCE_Z,0) = 0.000000; -NODES[529](BODY_FORCE_X,0) = 0.000000; -NODES[529](BODY_FORCE_Y,0) = -9.810000; -NODES[529](BODY_FORCE_Z,0) = 0.000000; -NODES[530](BODY_FORCE_X,0) = 0.000000; -NODES[530](BODY_FORCE_Y,0) = -9.810000; -NODES[530](BODY_FORCE_Z,0) = 0.000000; -NODES[531](BODY_FORCE_X,0) = 0.000000; -NODES[531](BODY_FORCE_Y,0) = -9.810000; -NODES[531](BODY_FORCE_Z,0) = 0.000000; -NODES[532](BODY_FORCE_X,0) = 0.000000; -NODES[532](BODY_FORCE_Y,0) = -9.810000; -NODES[532](BODY_FORCE_Z,0) = 0.000000; -NODES[533](BODY_FORCE_X,0) = 0.000000; -NODES[533](BODY_FORCE_Y,0) = -9.810000; -NODES[533](BODY_FORCE_Z,0) = 0.000000; -NODES[534](BODY_FORCE_X,0) = 0.000000; -NODES[534](BODY_FORCE_Y,0) = -9.810000; -NODES[534](BODY_FORCE_Z,0) = 0.000000; -NODES[535](BODY_FORCE_X,0) = 0.000000; -NODES[535](BODY_FORCE_Y,0) = -9.810000; -NODES[535](BODY_FORCE_Z,0) = 0.000000; -NODES[536](BODY_FORCE_X,0) = 0.000000; -NODES[536](BODY_FORCE_Y,0) = -9.810000; -NODES[536](BODY_FORCE_Z,0) = 0.000000; -NODES[537](BODY_FORCE_X,0) = 0.000000; -NODES[537](BODY_FORCE_Y,0) = -9.810000; -NODES[537](BODY_FORCE_Z,0) = 0.000000; -NODES[538](BODY_FORCE_X,0) = 0.000000; -NODES[538](BODY_FORCE_Y,0) = -9.810000; -NODES[538](BODY_FORCE_Z,0) = 0.000000; -NODES[539](BODY_FORCE_X,0) = 0.000000; -NODES[539](BODY_FORCE_Y,0) = -9.810000; -NODES[539](BODY_FORCE_Z,0) = 0.000000; -NODES[540](BODY_FORCE_X,0) = 0.000000; -NODES[540](BODY_FORCE_Y,0) = -9.810000; -NODES[540](BODY_FORCE_Z,0) = 0.000000; -NODES[541](BODY_FORCE_X,0) = 0.000000; -NODES[541](BODY_FORCE_Y,0) = -9.810000; -NODES[541](BODY_FORCE_Z,0) = 0.000000; -NODES[542](BODY_FORCE_X,0) = 0.000000; -NODES[542](BODY_FORCE_Y,0) = -9.810000; -NODES[542](BODY_FORCE_Z,0) = 0.000000; -NODES[543](BODY_FORCE_X,0) = 0.000000; -NODES[543](BODY_FORCE_Y,0) = -9.810000; -NODES[543](BODY_FORCE_Z,0) = 0.000000; -NODES[544](BODY_FORCE_X,0) = 0.000000; -NODES[544](BODY_FORCE_Y,0) = -9.810000; -NODES[544](BODY_FORCE_Z,0) = 0.000000; -NODES[545](BODY_FORCE_X,0) = 0.000000; -NODES[545](BODY_FORCE_Y,0) = -9.810000; -NODES[545](BODY_FORCE_Z,0) = 0.000000; -NODES[546](BODY_FORCE_X,0) = 0.000000; -NODES[546](BODY_FORCE_Y,0) = -9.810000; -NODES[546](BODY_FORCE_Z,0) = 0.000000; -NODES[547](BODY_FORCE_X,0) = 0.000000; -NODES[547](BODY_FORCE_Y,0) = -9.810000; -NODES[547](BODY_FORCE_Z,0) = 0.000000; -NODES[548](BODY_FORCE_X,0) = 0.000000; -NODES[548](BODY_FORCE_Y,0) = -9.810000; -NODES[548](BODY_FORCE_Z,0) = 0.000000; -NODES[549](BODY_FORCE_X,0) = 0.000000; -NODES[549](BODY_FORCE_Y,0) = -9.810000; -NODES[549](BODY_FORCE_Z,0) = 0.000000; -NODES[550](BODY_FORCE_X,0) = 0.000000; -NODES[550](BODY_FORCE_Y,0) = -9.810000; -NODES[550](BODY_FORCE_Z,0) = 0.000000; -NODES[551](BODY_FORCE_X,0) = 0.000000; -NODES[551](BODY_FORCE_Y,0) = -9.810000; -NODES[551](BODY_FORCE_Z,0) = 0.000000; -NODES[552](BODY_FORCE_X,0) = 0.000000; -NODES[552](BODY_FORCE_Y,0) = -9.810000; -NODES[552](BODY_FORCE_Z,0) = 0.000000; -NODES[553](BODY_FORCE_X,0) = 0.000000; -NODES[553](BODY_FORCE_Y,0) = -9.810000; -NODES[553](BODY_FORCE_Z,0) = 0.000000; -NODES[554](BODY_FORCE_X,0) = 0.000000; -NODES[554](BODY_FORCE_Y,0) = -9.810000; -NODES[554](BODY_FORCE_Z,0) = 0.000000; -NODES[555](BODY_FORCE_X,0) = 0.000000; -NODES[555](BODY_FORCE_Y,0) = -9.810000; -NODES[555](BODY_FORCE_Z,0) = 0.000000; -NODES[556](BODY_FORCE_X,0) = 0.000000; -NODES[556](BODY_FORCE_Y,0) = -9.810000; -NODES[556](BODY_FORCE_Z,0) = 0.000000; -NODES[557](BODY_FORCE_X,0) = 0.000000; -NODES[557](BODY_FORCE_Y,0) = -9.810000; -NODES[557](BODY_FORCE_Z,0) = 0.000000; -NODES[558](BODY_FORCE_X,0) = 0.000000; -NODES[558](BODY_FORCE_Y,0) = -9.810000; -NODES[558](BODY_FORCE_Z,0) = 0.000000; -NODES[559](BODY_FORCE_X,0) = 0.000000; -NODES[559](BODY_FORCE_Y,0) = -9.810000; -NODES[559](BODY_FORCE_Z,0) = 0.000000; -NODES[560](BODY_FORCE_X,0) = 0.000000; -NODES[560](BODY_FORCE_Y,0) = -9.810000; -NODES[560](BODY_FORCE_Z,0) = 0.000000; -NODES[561](BODY_FORCE_X,0) = 0.000000; -NODES[561](BODY_FORCE_Y,0) = -9.810000; -NODES[561](BODY_FORCE_Z,0) = 0.000000; -NODES[562](BODY_FORCE_X,0) = 0.000000; -NODES[562](BODY_FORCE_Y,0) = -9.810000; -NODES[562](BODY_FORCE_Z,0) = 0.000000; -NODES[563](BODY_FORCE_X,0) = 0.000000; -NODES[563](BODY_FORCE_Y,0) = -9.810000; -NODES[563](BODY_FORCE_Z,0) = 0.000000; -NODES[564](BODY_FORCE_X,0) = 0.000000; -NODES[564](BODY_FORCE_Y,0) = -9.810000; -NODES[564](BODY_FORCE_Z,0) = 0.000000; -NODES[565](BODY_FORCE_X,0) = 0.000000; -NODES[565](BODY_FORCE_Y,0) = -9.810000; -NODES[565](BODY_FORCE_Z,0) = 0.000000; -NODES[566](BODY_FORCE_X,0) = 0.000000; -NODES[566](BODY_FORCE_Y,0) = -9.810000; -NODES[566](BODY_FORCE_Z,0) = 0.000000; -NODES[567](BODY_FORCE_X,0) = 0.000000; -NODES[567](BODY_FORCE_Y,0) = -9.810000; -NODES[567](BODY_FORCE_Z,0) = 0.000000; -NODES[568](BODY_FORCE_X,0) = 0.000000; -NODES[568](BODY_FORCE_Y,0) = -9.810000; -NODES[568](BODY_FORCE_Z,0) = 0.000000; -NODES[569](BODY_FORCE_X,0) = 0.000000; -NODES[569](BODY_FORCE_Y,0) = -9.810000; -NODES[569](BODY_FORCE_Z,0) = 0.000000; -NODES[571](BODY_FORCE_X,0) = 0.000000; -NODES[571](BODY_FORCE_Y,0) = -9.810000; -NODES[571](BODY_FORCE_Z,0) = 0.000000; -NODES[572](BODY_FORCE_X,0) = 0.000000; -NODES[572](BODY_FORCE_Y,0) = -9.810000; -NODES[572](BODY_FORCE_Z,0) = 0.000000; -NODES[573](BODY_FORCE_X,0) = 0.000000; -NODES[573](BODY_FORCE_Y,0) = -9.810000; -NODES[573](BODY_FORCE_Z,0) = 0.000000; -NODES[574](BODY_FORCE_X,0) = 0.000000; -NODES[574](BODY_FORCE_Y,0) = -9.810000; -NODES[574](BODY_FORCE_Z,0) = 0.000000; -NODES[575](BODY_FORCE_X,0) = 0.000000; -NODES[575](BODY_FORCE_Y,0) = -9.810000; -NODES[575](BODY_FORCE_Z,0) = 0.000000; -NODES[576](BODY_FORCE_X,0) = 0.000000; -NODES[576](BODY_FORCE_Y,0) = -9.810000; -NODES[576](BODY_FORCE_Z,0) = 0.000000; -NODES[577](BODY_FORCE_X,0) = 0.000000; -NODES[577](BODY_FORCE_Y,0) = -9.810000; -NODES[577](BODY_FORCE_Z,0) = 0.000000; -NODES[578](BODY_FORCE_X,0) = 0.000000; -NODES[578](BODY_FORCE_Y,0) = -9.810000; -NODES[578](BODY_FORCE_Z,0) = 0.000000; -NODES[579](BODY_FORCE_X,0) = 0.000000; -NODES[579](BODY_FORCE_Y,0) = -9.810000; -NODES[579](BODY_FORCE_Z,0) = 0.000000; -NODES[580](BODY_FORCE_X,0) = 0.000000; -NODES[580](BODY_FORCE_Y,0) = -9.810000; -NODES[580](BODY_FORCE_Z,0) = 0.000000; -NODES[581](BODY_FORCE_X,0) = 0.000000; -NODES[581](BODY_FORCE_Y,0) = -9.810000; -NODES[581](BODY_FORCE_Z,0) = 0.000000; -NODES[582](BODY_FORCE_X,0) = 0.000000; -NODES[582](BODY_FORCE_Y,0) = -9.810000; -NODES[582](BODY_FORCE_Z,0) = 0.000000; -NODES[583](BODY_FORCE_X,0) = 0.000000; -NODES[583](BODY_FORCE_Y,0) = -9.810000; -NODES[583](BODY_FORCE_Z,0) = 0.000000; -NODES[584](BODY_FORCE_X,0) = 0.000000; -NODES[584](BODY_FORCE_Y,0) = -9.810000; -NODES[584](BODY_FORCE_Z,0) = 0.000000; -NODES[585](BODY_FORCE_X,0) = 0.000000; -NODES[585](BODY_FORCE_Y,0) = -9.810000; -NODES[585](BODY_FORCE_Z,0) = 0.000000; -NODES[586](BODY_FORCE_X,0) = 0.000000; -NODES[586](BODY_FORCE_Y,0) = -9.810000; -NODES[586](BODY_FORCE_Z,0) = 0.000000; -NODES[587](BODY_FORCE_X,0) = 0.000000; -NODES[587](BODY_FORCE_Y,0) = -9.810000; -NODES[587](BODY_FORCE_Z,0) = 0.000000; -NODES[588](BODY_FORCE_X,0) = 0.000000; -NODES[588](BODY_FORCE_Y,0) = -9.810000; -NODES[588](BODY_FORCE_Z,0) = 0.000000; -NODES[589](BODY_FORCE_X,0) = 0.000000; -NODES[589](BODY_FORCE_Y,0) = -9.810000; -NODES[589](BODY_FORCE_Z,0) = 0.000000; -NODES[590](BODY_FORCE_X,0) = 0.000000; -NODES[590](BODY_FORCE_Y,0) = -9.810000; -NODES[590](BODY_FORCE_Z,0) = 0.000000; -NODES[591](BODY_FORCE_X,0) = 0.000000; -NODES[591](BODY_FORCE_Y,0) = -9.810000; -NODES[591](BODY_FORCE_Z,0) = 0.000000; -NODES[592](BODY_FORCE_X,0) = 0.000000; -NODES[592](BODY_FORCE_Y,0) = -9.810000; -NODES[592](BODY_FORCE_Z,0) = 0.000000; -NODES[593](BODY_FORCE_X,0) = 0.000000; -NODES[593](BODY_FORCE_Y,0) = -9.810000; -NODES[593](BODY_FORCE_Z,0) = 0.000000; -NODES[594](BODY_FORCE_X,0) = 0.000000; -NODES[594](BODY_FORCE_Y,0) = -9.810000; -NODES[594](BODY_FORCE_Z,0) = 0.000000; -NODES[595](BODY_FORCE_X,0) = 0.000000; -NODES[595](BODY_FORCE_Y,0) = -9.810000; -NODES[595](BODY_FORCE_Z,0) = 0.000000; -NODES[596](BODY_FORCE_X,0) = 0.000000; -NODES[596](BODY_FORCE_Y,0) = -9.810000; -NODES[596](BODY_FORCE_Z,0) = 0.000000; -NODES[597](BODY_FORCE_X,0) = 0.000000; -NODES[597](BODY_FORCE_Y,0) = -9.810000; -NODES[597](BODY_FORCE_Z,0) = 0.000000; -NODES[598](BODY_FORCE_X,0) = 0.000000; -NODES[598](BODY_FORCE_Y,0) = -9.810000; -NODES[598](BODY_FORCE_Z,0) = 0.000000; -NODES[599](BODY_FORCE_X,0) = 0.000000; -NODES[599](BODY_FORCE_Y,0) = -9.810000; -NODES[599](BODY_FORCE_Z,0) = 0.000000; -NODES[600](BODY_FORCE_X,0) = 0.000000; -NODES[600](BODY_FORCE_Y,0) = -9.810000; -NODES[600](BODY_FORCE_Z,0) = 0.000000; -NODES[601](BODY_FORCE_X,0) = 0.000000; -NODES[601](BODY_FORCE_Y,0) = -9.810000; -NODES[601](BODY_FORCE_Z,0) = 0.000000; -NODES[602](BODY_FORCE_X,0) = 0.000000; -NODES[602](BODY_FORCE_Y,0) = -9.810000; -NODES[602](BODY_FORCE_Z,0) = 0.000000; -NODES[603](BODY_FORCE_X,0) = 0.000000; -NODES[603](BODY_FORCE_Y,0) = -9.810000; -NODES[603](BODY_FORCE_Z,0) = 0.000000; -NODES[604](BODY_FORCE_X,0) = 0.000000; -NODES[604](BODY_FORCE_Y,0) = -9.810000; -NODES[604](BODY_FORCE_Z,0) = 0.000000; -NODES[605](BODY_FORCE_X,0) = 0.000000; -NODES[605](BODY_FORCE_Y,0) = -9.810000; -NODES[605](BODY_FORCE_Z,0) = 0.000000; -NODES[606](BODY_FORCE_X,0) = 0.000000; -NODES[606](BODY_FORCE_Y,0) = -9.810000; -NODES[606](BODY_FORCE_Z,0) = 0.000000; -NODES[607](BODY_FORCE_X,0) = 0.000000; -NODES[607](BODY_FORCE_Y,0) = -9.810000; -NODES[607](BODY_FORCE_Z,0) = 0.000000; -NODES[608](BODY_FORCE_X,0) = 0.000000; -NODES[608](BODY_FORCE_Y,0) = -9.810000; -NODES[608](BODY_FORCE_Z,0) = 0.000000; -NODES[609](BODY_FORCE_X,0) = 0.000000; -NODES[609](BODY_FORCE_Y,0) = -9.810000; -NODES[609](BODY_FORCE_Z,0) = 0.000000; -NODES[610](BODY_FORCE_X,0) = 0.000000; -NODES[610](BODY_FORCE_Y,0) = -9.810000; -NODES[610](BODY_FORCE_Z,0) = 0.000000; -NODES[611](BODY_FORCE_X,0) = 0.000000; -NODES[611](BODY_FORCE_Y,0) = -9.810000; -NODES[611](BODY_FORCE_Z,0) = 0.000000; -NODES[612](BODY_FORCE_X,0) = 0.000000; -NODES[612](BODY_FORCE_Y,0) = -9.810000; -NODES[612](BODY_FORCE_Z,0) = 0.000000; -NODES[613](BODY_FORCE_X,0) = 0.000000; -NODES[613](BODY_FORCE_Y,0) = -9.810000; -NODES[613](BODY_FORCE_Z,0) = 0.000000; -NODES[614](BODY_FORCE_X,0) = 0.000000; -NODES[614](BODY_FORCE_Y,0) = -9.810000; -NODES[614](BODY_FORCE_Z,0) = 0.000000; -NODES[615](BODY_FORCE_X,0) = 0.000000; -NODES[615](BODY_FORCE_Y,0) = -9.810000; -NODES[615](BODY_FORCE_Z,0) = 0.000000; -NODES[616](BODY_FORCE_X,0) = 0.000000; -NODES[616](BODY_FORCE_Y,0) = -9.810000; -NODES[616](BODY_FORCE_Z,0) = 0.000000; -NODES[617](BODY_FORCE_X,0) = 0.000000; -NODES[617](BODY_FORCE_Y,0) = -9.810000; -NODES[617](BODY_FORCE_Z,0) = 0.000000; -NODES[618](BODY_FORCE_X,0) = 0.000000; -NODES[618](BODY_FORCE_Y,0) = -9.810000; -NODES[618](BODY_FORCE_Z,0) = 0.000000; -NODES[619](BODY_FORCE_X,0) = 0.000000; -NODES[619](BODY_FORCE_Y,0) = -9.810000; -NODES[619](BODY_FORCE_Z,0) = 0.000000; -NODES[620](BODY_FORCE_X,0) = 0.000000; -NODES[620](BODY_FORCE_Y,0) = -9.810000; -NODES[620](BODY_FORCE_Z,0) = 0.000000; -NODES[621](BODY_FORCE_X,0) = 0.000000; -NODES[621](BODY_FORCE_Y,0) = -9.810000; -NODES[621](BODY_FORCE_Z,0) = 0.000000; -NODES[623](BODY_FORCE_X,0) = 0.000000; -NODES[623](BODY_FORCE_Y,0) = -9.810000; -NODES[623](BODY_FORCE_Z,0) = 0.000000; -NODES[624](BODY_FORCE_X,0) = 0.000000; -NODES[624](BODY_FORCE_Y,0) = -9.810000; -NODES[624](BODY_FORCE_Z,0) = 0.000000; -NODES[625](BODY_FORCE_X,0) = 0.000000; -NODES[625](BODY_FORCE_Y,0) = -9.810000; -NODES[625](BODY_FORCE_Z,0) = 0.000000; -NODES[626](BODY_FORCE_X,0) = 0.000000; -NODES[626](BODY_FORCE_Y,0) = -9.810000; -NODES[626](BODY_FORCE_Z,0) = 0.000000; -NODES[627](BODY_FORCE_X,0) = 0.000000; -NODES[627](BODY_FORCE_Y,0) = -9.810000; -NODES[627](BODY_FORCE_Z,0) = 0.000000; -NODES[628](BODY_FORCE_X,0) = 0.000000; -NODES[628](BODY_FORCE_Y,0) = -9.810000; -NODES[628](BODY_FORCE_Z,0) = 0.000000; -NODES[629](BODY_FORCE_X,0) = 0.000000; -NODES[629](BODY_FORCE_Y,0) = -9.810000; -NODES[629](BODY_FORCE_Z,0) = 0.000000; -NODES[630](BODY_FORCE_X,0) = 0.000000; -NODES[630](BODY_FORCE_Y,0) = -9.810000; -NODES[630](BODY_FORCE_Z,0) = 0.000000; -NODES[631](BODY_FORCE_X,0) = 0.000000; -NODES[631](BODY_FORCE_Y,0) = -9.810000; -NODES[631](BODY_FORCE_Z,0) = 0.000000; -NODES[632](BODY_FORCE_X,0) = 0.000000; -NODES[632](BODY_FORCE_Y,0) = -9.810000; -NODES[632](BODY_FORCE_Z,0) = 0.000000; -NODES[633](BODY_FORCE_X,0) = 0.000000; -NODES[633](BODY_FORCE_Y,0) = -9.810000; -NODES[633](BODY_FORCE_Z,0) = 0.000000; -NODES[634](BODY_FORCE_X,0) = 0.000000; -NODES[634](BODY_FORCE_Y,0) = -9.810000; -NODES[634](BODY_FORCE_Z,0) = 0.000000; -NODES[635](BODY_FORCE_X,0) = 0.000000; -NODES[635](BODY_FORCE_Y,0) = -9.810000; -NODES[635](BODY_FORCE_Z,0) = 0.000000; -NODES[636](BODY_FORCE_X,0) = 0.000000; -NODES[636](BODY_FORCE_Y,0) = -9.810000; -NODES[636](BODY_FORCE_Z,0) = 0.000000; -NODES[637](BODY_FORCE_X,0) = 0.000000; -NODES[637](BODY_FORCE_Y,0) = -9.810000; -NODES[637](BODY_FORCE_Z,0) = 0.000000; -NODES[638](BODY_FORCE_X,0) = 0.000000; -NODES[638](BODY_FORCE_Y,0) = -9.810000; -NODES[638](BODY_FORCE_Z,0) = 0.000000; -NODES[639](BODY_FORCE_X,0) = 0.000000; -NODES[639](BODY_FORCE_Y,0) = -9.810000; -NODES[639](BODY_FORCE_Z,0) = 0.000000; -NODES[640](BODY_FORCE_X,0) = 0.000000; -NODES[640](BODY_FORCE_Y,0) = -9.810000; -NODES[640](BODY_FORCE_Z,0) = 0.000000; -NODES[641](BODY_FORCE_X,0) = 0.000000; -NODES[641](BODY_FORCE_Y,0) = -9.810000; -NODES[641](BODY_FORCE_Z,0) = 0.000000; -NODES[642](BODY_FORCE_X,0) = 0.000000; -NODES[642](BODY_FORCE_Y,0) = -9.810000; -NODES[642](BODY_FORCE_Z,0) = 0.000000; -NODES[643](BODY_FORCE_X,0) = 0.000000; -NODES[643](BODY_FORCE_Y,0) = -9.810000; -NODES[643](BODY_FORCE_Z,0) = 0.000000; -NODES[644](BODY_FORCE_X,0) = 0.000000; -NODES[644](BODY_FORCE_Y,0) = -9.810000; -NODES[644](BODY_FORCE_Z,0) = 0.000000; -NODES[645](BODY_FORCE_X,0) = 0.000000; -NODES[645](BODY_FORCE_Y,0) = -9.810000; -NODES[645](BODY_FORCE_Z,0) = 0.000000; -NODES[646](BODY_FORCE_X,0) = 0.000000; -NODES[646](BODY_FORCE_Y,0) = -9.810000; -NODES[646](BODY_FORCE_Z,0) = 0.000000; -NODES[647](BODY_FORCE_X,0) = 0.000000; -NODES[647](BODY_FORCE_Y,0) = -9.810000; -NODES[647](BODY_FORCE_Z,0) = 0.000000; -NODES[648](BODY_FORCE_X,0) = 0.000000; -NODES[648](BODY_FORCE_Y,0) = -9.810000; -NODES[648](BODY_FORCE_Z,0) = 0.000000; -NODES[649](BODY_FORCE_X,0) = 0.000000; -NODES[649](BODY_FORCE_Y,0) = -9.810000; -NODES[649](BODY_FORCE_Z,0) = 0.000000; -NODES[650](BODY_FORCE_X,0) = 0.000000; -NODES[650](BODY_FORCE_Y,0) = -9.810000; -NODES[650](BODY_FORCE_Z,0) = 0.000000; -NODES[651](BODY_FORCE_X,0) = 0.000000; -NODES[651](BODY_FORCE_Y,0) = -9.810000; -NODES[651](BODY_FORCE_Z,0) = 0.000000; -NODES[652](BODY_FORCE_X,0) = 0.000000; -NODES[652](BODY_FORCE_Y,0) = -9.810000; -NODES[652](BODY_FORCE_Z,0) = 0.000000; -NODES[653](BODY_FORCE_X,0) = 0.000000; -NODES[653](BODY_FORCE_Y,0) = -9.810000; -NODES[653](BODY_FORCE_Z,0) = 0.000000; -NODES[654](BODY_FORCE_X,0) = 0.000000; -NODES[654](BODY_FORCE_Y,0) = -9.810000; -NODES[654](BODY_FORCE_Z,0) = 0.000000; -NODES[655](BODY_FORCE_X,0) = 0.000000; -NODES[655](BODY_FORCE_Y,0) = -9.810000; -NODES[655](BODY_FORCE_Z,0) = 0.000000; -NODES[656](BODY_FORCE_X,0) = 0.000000; -NODES[656](BODY_FORCE_Y,0) = -9.810000; -NODES[656](BODY_FORCE_Z,0) = 0.000000; -NODES[657](BODY_FORCE_X,0) = 0.000000; -NODES[657](BODY_FORCE_Y,0) = -9.810000; -NODES[657](BODY_FORCE_Z,0) = 0.000000; -NODES[658](BODY_FORCE_X,0) = 0.000000; -NODES[658](BODY_FORCE_Y,0) = -9.810000; -NODES[658](BODY_FORCE_Z,0) = 0.000000; -NODES[659](BODY_FORCE_X,0) = 0.000000; -NODES[659](BODY_FORCE_Y,0) = -9.810000; -NODES[659](BODY_FORCE_Z,0) = 0.000000; -NODES[660](BODY_FORCE_X,0) = 0.000000; -NODES[660](BODY_FORCE_Y,0) = -9.810000; -NODES[660](BODY_FORCE_Z,0) = 0.000000; -NODES[661](BODY_FORCE_X,0) = 0.000000; -NODES[661](BODY_FORCE_Y,0) = -9.810000; -NODES[661](BODY_FORCE_Z,0) = 0.000000; -NODES[662](BODY_FORCE_X,0) = 0.000000; -NODES[662](BODY_FORCE_Y,0) = -9.810000; -NODES[662](BODY_FORCE_Z,0) = 0.000000; -NODES[663](BODY_FORCE_X,0) = 0.000000; -NODES[663](BODY_FORCE_Y,0) = -9.810000; -NODES[663](BODY_FORCE_Z,0) = 0.000000; -NODES[664](BODY_FORCE_X,0) = 0.000000; -NODES[664](BODY_FORCE_Y,0) = -9.810000; -NODES[664](BODY_FORCE_Z,0) = 0.000000; -NODES[665](BODY_FORCE_X,0) = 0.000000; -NODES[665](BODY_FORCE_Y,0) = -9.810000; -NODES[665](BODY_FORCE_Z,0) = 0.000000; -NODES[666](BODY_FORCE_X,0) = 0.000000; -NODES[666](BODY_FORCE_Y,0) = -9.810000; -NODES[666](BODY_FORCE_Z,0) = 0.000000; -NODES[667](BODY_FORCE_X,0) = 0.000000; -NODES[667](BODY_FORCE_Y,0) = -9.810000; -NODES[667](BODY_FORCE_Z,0) = 0.000000; -NODES[668](BODY_FORCE_X,0) = 0.000000; -NODES[668](BODY_FORCE_Y,0) = -9.810000; -NODES[668](BODY_FORCE_Z,0) = 0.000000; -NODES[669](BODY_FORCE_X,0) = 0.000000; -NODES[669](BODY_FORCE_Y,0) = -9.810000; -NODES[669](BODY_FORCE_Z,0) = 0.000000; -NODES[670](BODY_FORCE_X,0) = 0.000000; -NODES[670](BODY_FORCE_Y,0) = -9.810000; -NODES[670](BODY_FORCE_Z,0) = 0.000000; -NODES[671](BODY_FORCE_X,0) = 0.000000; -NODES[671](BODY_FORCE_Y,0) = -9.810000; -NODES[671](BODY_FORCE_Z,0) = 0.000000; -NODES[672](BODY_FORCE_X,0) = 0.000000; -NODES[672](BODY_FORCE_Y,0) = -9.810000; -NODES[672](BODY_FORCE_Z,0) = 0.000000; -NODES[673](BODY_FORCE_X,0) = 0.000000; -NODES[673](BODY_FORCE_Y,0) = -9.810000; -NODES[673](BODY_FORCE_Z,0) = 0.000000; -NODES[674](BODY_FORCE_X,0) = 0.000000; -NODES[674](BODY_FORCE_Y,0) = -9.810000; -NODES[674](BODY_FORCE_Z,0) = 0.000000; -NODES[675](BODY_FORCE_X,0) = 0.000000; -NODES[675](BODY_FORCE_Y,0) = -9.810000; -NODES[675](BODY_FORCE_Z,0) = 0.000000; -NODES[676](BODY_FORCE_X,0) = 0.000000; -NODES[676](BODY_FORCE_Y,0) = -9.810000; -NODES[676](BODY_FORCE_Z,0) = 0.000000; -NODES[678](BODY_FORCE_X,0) = 0.000000; -NODES[678](BODY_FORCE_Y,0) = -9.810000; -NODES[678](BODY_FORCE_Z,0) = 0.000000; -NODES[679](BODY_FORCE_X,0) = 0.000000; -NODES[679](BODY_FORCE_Y,0) = -9.810000; -NODES[679](BODY_FORCE_Z,0) = 0.000000; -NODES[680](BODY_FORCE_X,0) = 0.000000; -NODES[680](BODY_FORCE_Y,0) = -9.810000; -NODES[680](BODY_FORCE_Z,0) = 0.000000; -NODES[681](BODY_FORCE_X,0) = 0.000000; -NODES[681](BODY_FORCE_Y,0) = -9.810000; -NODES[681](BODY_FORCE_Z,0) = 0.000000; -NODES[682](BODY_FORCE_X,0) = 0.000000; -NODES[682](BODY_FORCE_Y,0) = -9.810000; -NODES[682](BODY_FORCE_Z,0) = 0.000000; -NODES[683](BODY_FORCE_X,0) = 0.000000; -NODES[683](BODY_FORCE_Y,0) = -9.810000; -NODES[683](BODY_FORCE_Z,0) = 0.000000; -NODES[684](BODY_FORCE_X,0) = 0.000000; -NODES[684](BODY_FORCE_Y,0) = -9.810000; -NODES[684](BODY_FORCE_Z,0) = 0.000000; -NODES[685](BODY_FORCE_X,0) = 0.000000; -NODES[685](BODY_FORCE_Y,0) = -9.810000; -NODES[685](BODY_FORCE_Z,0) = 0.000000; -NODES[686](BODY_FORCE_X,0) = 0.000000; -NODES[686](BODY_FORCE_Y,0) = -9.810000; -NODES[686](BODY_FORCE_Z,0) = 0.000000; -NODES[687](BODY_FORCE_X,0) = 0.000000; -NODES[687](BODY_FORCE_Y,0) = -9.810000; -NODES[687](BODY_FORCE_Z,0) = 0.000000; -NODES[688](BODY_FORCE_X,0) = 0.000000; -NODES[688](BODY_FORCE_Y,0) = -9.810000; -NODES[688](BODY_FORCE_Z,0) = 0.000000; -NODES[689](BODY_FORCE_X,0) = 0.000000; -NODES[689](BODY_FORCE_Y,0) = -9.810000; -NODES[689](BODY_FORCE_Z,0) = 0.000000; -NODES[690](BODY_FORCE_X,0) = 0.000000; -NODES[690](BODY_FORCE_Y,0) = -9.810000; -NODES[690](BODY_FORCE_Z,0) = 0.000000; -NODES[691](BODY_FORCE_X,0) = 0.000000; -NODES[691](BODY_FORCE_Y,0) = -9.810000; -NODES[691](BODY_FORCE_Z,0) = 0.000000; -NODES[692](BODY_FORCE_X,0) = 0.000000; -NODES[692](BODY_FORCE_Y,0) = -9.810000; -NODES[692](BODY_FORCE_Z,0) = 0.000000; -NODES[693](BODY_FORCE_X,0) = 0.000000; -NODES[693](BODY_FORCE_Y,0) = -9.810000; -NODES[693](BODY_FORCE_Z,0) = 0.000000; -NODES[694](BODY_FORCE_X,0) = 0.000000; -NODES[694](BODY_FORCE_Y,0) = -9.810000; -NODES[694](BODY_FORCE_Z,0) = 0.000000; -NODES[695](BODY_FORCE_X,0) = 0.000000; -NODES[695](BODY_FORCE_Y,0) = -9.810000; -NODES[695](BODY_FORCE_Z,0) = 0.000000; -NODES[696](BODY_FORCE_X,0) = 0.000000; -NODES[696](BODY_FORCE_Y,0) = -9.810000; -NODES[696](BODY_FORCE_Z,0) = 0.000000; -NODES[697](BODY_FORCE_X,0) = 0.000000; -NODES[697](BODY_FORCE_Y,0) = -9.810000; -NODES[697](BODY_FORCE_Z,0) = 0.000000; -NODES[698](BODY_FORCE_X,0) = 0.000000; -NODES[698](BODY_FORCE_Y,0) = -9.810000; -NODES[698](BODY_FORCE_Z,0) = 0.000000; -NODES[699](BODY_FORCE_X,0) = 0.000000; -NODES[699](BODY_FORCE_Y,0) = -9.810000; -NODES[699](BODY_FORCE_Z,0) = 0.000000; -NODES[700](BODY_FORCE_X,0) = 0.000000; -NODES[700](BODY_FORCE_Y,0) = -9.810000; -NODES[700](BODY_FORCE_Z,0) = 0.000000; -NODES[701](BODY_FORCE_X,0) = 0.000000; -NODES[701](BODY_FORCE_Y,0) = -9.810000; -NODES[701](BODY_FORCE_Z,0) = 0.000000; -NODES[702](BODY_FORCE_X,0) = 0.000000; -NODES[702](BODY_FORCE_Y,0) = -9.810000; -NODES[702](BODY_FORCE_Z,0) = 0.000000; -NODES[703](BODY_FORCE_X,0) = 0.000000; -NODES[703](BODY_FORCE_Y,0) = -9.810000; -NODES[703](BODY_FORCE_Z,0) = 0.000000; -NODES[704](BODY_FORCE_X,0) = 0.000000; -NODES[704](BODY_FORCE_Y,0) = -9.810000; -NODES[704](BODY_FORCE_Z,0) = 0.000000; -NODES[705](BODY_FORCE_X,0) = 0.000000; -NODES[705](BODY_FORCE_Y,0) = -9.810000; -NODES[705](BODY_FORCE_Z,0) = 0.000000; -NODES[706](BODY_FORCE_X,0) = 0.000000; -NODES[706](BODY_FORCE_Y,0) = -9.810000; -NODES[706](BODY_FORCE_Z,0) = 0.000000; -NODES[707](BODY_FORCE_X,0) = 0.000000; -NODES[707](BODY_FORCE_Y,0) = -9.810000; -NODES[707](BODY_FORCE_Z,0) = 0.000000; -NODES[708](BODY_FORCE_X,0) = 0.000000; -NODES[708](BODY_FORCE_Y,0) = -9.810000; -NODES[708](BODY_FORCE_Z,0) = 0.000000; -NODES[709](BODY_FORCE_X,0) = 0.000000; -NODES[709](BODY_FORCE_Y,0) = -9.810000; -NODES[709](BODY_FORCE_Z,0) = 0.000000; -NODES[710](BODY_FORCE_X,0) = 0.000000; -NODES[710](BODY_FORCE_Y,0) = -9.810000; -NODES[710](BODY_FORCE_Z,0) = 0.000000; -NODES[711](BODY_FORCE_X,0) = 0.000000; -NODES[711](BODY_FORCE_Y,0) = -9.810000; -NODES[711](BODY_FORCE_Z,0) = 0.000000; -NODES[712](BODY_FORCE_X,0) = 0.000000; -NODES[712](BODY_FORCE_Y,0) = -9.810000; -NODES[712](BODY_FORCE_Z,0) = 0.000000; -NODES[713](BODY_FORCE_X,0) = 0.000000; -NODES[713](BODY_FORCE_Y,0) = -9.810000; -NODES[713](BODY_FORCE_Z,0) = 0.000000; -NODES[714](BODY_FORCE_X,0) = 0.000000; -NODES[714](BODY_FORCE_Y,0) = -9.810000; -NODES[714](BODY_FORCE_Z,0) = 0.000000; -NODES[715](BODY_FORCE_X,0) = 0.000000; -NODES[715](BODY_FORCE_Y,0) = -9.810000; -NODES[715](BODY_FORCE_Z,0) = 0.000000; -NODES[716](BODY_FORCE_X,0) = 0.000000; -NODES[716](BODY_FORCE_Y,0) = -9.810000; -NODES[716](BODY_FORCE_Z,0) = 0.000000; -NODES[717](BODY_FORCE_X,0) = 0.000000; -NODES[717](BODY_FORCE_Y,0) = -9.810000; -NODES[717](BODY_FORCE_Z,0) = 0.000000; -NODES[718](BODY_FORCE_X,0) = 0.000000; -NODES[718](BODY_FORCE_Y,0) = -9.810000; -NODES[718](BODY_FORCE_Z,0) = 0.000000; -NODES[719](BODY_FORCE_X,0) = 0.000000; -NODES[719](BODY_FORCE_Y,0) = -9.810000; -NODES[719](BODY_FORCE_Z,0) = 0.000000; -NODES[720](BODY_FORCE_X,0) = 0.000000; -NODES[720](BODY_FORCE_Y,0) = -9.810000; -NODES[720](BODY_FORCE_Z,0) = 0.000000; -NODES[721](BODY_FORCE_X,0) = 0.000000; -NODES[721](BODY_FORCE_Y,0) = -9.810000; -NODES[721](BODY_FORCE_Z,0) = 0.000000; -NODES[722](BODY_FORCE_X,0) = 0.000000; -NODES[722](BODY_FORCE_Y,0) = -9.810000; -NODES[722](BODY_FORCE_Z,0) = 0.000000; -NODES[723](BODY_FORCE_X,0) = 0.000000; -NODES[723](BODY_FORCE_Y,0) = -9.810000; -NODES[723](BODY_FORCE_Z,0) = 0.000000; -NODES[724](BODY_FORCE_X,0) = 0.000000; -NODES[724](BODY_FORCE_Y,0) = -9.810000; -NODES[724](BODY_FORCE_Z,0) = 0.000000; -NODES[725](BODY_FORCE_X,0) = 0.000000; -NODES[725](BODY_FORCE_Y,0) = -9.810000; -NODES[725](BODY_FORCE_Z,0) = 0.000000; -NODES[726](BODY_FORCE_X,0) = 0.000000; -NODES[726](BODY_FORCE_Y,0) = -9.810000; -NODES[726](BODY_FORCE_Z,0) = 0.000000; -NODES[727](BODY_FORCE_X,0) = 0.000000; -NODES[727](BODY_FORCE_Y,0) = -9.810000; -NODES[727](BODY_FORCE_Z,0) = 0.000000; -NODES[728](BODY_FORCE_X,0) = 0.000000; -NODES[728](BODY_FORCE_Y,0) = -9.810000; -NODES[728](BODY_FORCE_Z,0) = 0.000000; -NODES[729](BODY_FORCE_X,0) = 0.000000; -NODES[729](BODY_FORCE_Y,0) = -9.810000; -NODES[729](BODY_FORCE_Z,0) = 0.000000; -NODES[730](BODY_FORCE_X,0) = 0.000000; -NODES[730](BODY_FORCE_Y,0) = -9.810000; -NODES[730](BODY_FORCE_Z,0) = 0.000000; -NODES[731](BODY_FORCE_X,0) = 0.000000; -NODES[731](BODY_FORCE_Y,0) = -9.810000; -NODES[731](BODY_FORCE_Z,0) = 0.000000; -NODES[732](BODY_FORCE_X,0) = 0.000000; -NODES[732](BODY_FORCE_Y,0) = -9.810000; -NODES[732](BODY_FORCE_Z,0) = 0.000000; -NODES[733](BODY_FORCE_X,0) = 0.000000; -NODES[733](BODY_FORCE_Y,0) = -9.810000; -NODES[733](BODY_FORCE_Z,0) = 0.000000; -NODES[734](BODY_FORCE_X,0) = 0.000000; -NODES[734](BODY_FORCE_Y,0) = -9.810000; -NODES[734](BODY_FORCE_Z,0) = 0.000000; -NODES[735](BODY_FORCE_X,0) = 0.000000; -NODES[735](BODY_FORCE_Y,0) = -9.810000; -NODES[735](BODY_FORCE_Z,0) = 0.000000; -NODES[736](BODY_FORCE_X,0) = 0.000000; -NODES[736](BODY_FORCE_Y,0) = -9.810000; -NODES[736](BODY_FORCE_Z,0) = 0.000000; -NODES[737](BODY_FORCE_X,0) = 0.000000; -NODES[737](BODY_FORCE_Y,0) = -9.810000; -NODES[737](BODY_FORCE_Z,0) = 0.000000; -NODES[739](BODY_FORCE_X,0) = 0.000000; -NODES[739](BODY_FORCE_Y,0) = -9.810000; -NODES[739](BODY_FORCE_Z,0) = 0.000000; -NODES[740](BODY_FORCE_X,0) = 0.000000; -NODES[740](BODY_FORCE_Y,0) = -9.810000; -NODES[740](BODY_FORCE_Z,0) = 0.000000; -NODES[741](BODY_FORCE_X,0) = 0.000000; -NODES[741](BODY_FORCE_Y,0) = -9.810000; -NODES[741](BODY_FORCE_Z,0) = 0.000000; -NODES[742](BODY_FORCE_X,0) = 0.000000; -NODES[742](BODY_FORCE_Y,0) = -9.810000; -NODES[742](BODY_FORCE_Z,0) = 0.000000; -NODES[743](BODY_FORCE_X,0) = 0.000000; -NODES[743](BODY_FORCE_Y,0) = -9.810000; -NODES[743](BODY_FORCE_Z,0) = 0.000000; -NODES[744](BODY_FORCE_X,0) = 0.000000; -NODES[744](BODY_FORCE_Y,0) = -9.810000; -NODES[744](BODY_FORCE_Z,0) = 0.000000; -NODES[745](BODY_FORCE_X,0) = 0.000000; -NODES[745](BODY_FORCE_Y,0) = -9.810000; -NODES[745](BODY_FORCE_Z,0) = 0.000000; -NODES[746](BODY_FORCE_X,0) = 0.000000; -NODES[746](BODY_FORCE_Y,0) = -9.810000; -NODES[746](BODY_FORCE_Z,0) = 0.000000; -NODES[747](BODY_FORCE_X,0) = 0.000000; -NODES[747](BODY_FORCE_Y,0) = -9.810000; -NODES[747](BODY_FORCE_Z,0) = 0.000000; -NODES[748](BODY_FORCE_X,0) = 0.000000; -NODES[748](BODY_FORCE_Y,0) = -9.810000; -NODES[748](BODY_FORCE_Z,0) = 0.000000; -NODES[749](BODY_FORCE_X,0) = 0.000000; -NODES[749](BODY_FORCE_Y,0) = -9.810000; -NODES[749](BODY_FORCE_Z,0) = 0.000000; -NODES[750](BODY_FORCE_X,0) = 0.000000; -NODES[750](BODY_FORCE_Y,0) = -9.810000; -NODES[750](BODY_FORCE_Z,0) = 0.000000; -NODES[751](BODY_FORCE_X,0) = 0.000000; -NODES[751](BODY_FORCE_Y,0) = -9.810000; -NODES[751](BODY_FORCE_Z,0) = 0.000000; -NODES[752](BODY_FORCE_X,0) = 0.000000; -NODES[752](BODY_FORCE_Y,0) = -9.810000; -NODES[752](BODY_FORCE_Z,0) = 0.000000; -NODES[753](BODY_FORCE_X,0) = 0.000000; -NODES[753](BODY_FORCE_Y,0) = -9.810000; -NODES[753](BODY_FORCE_Z,0) = 0.000000; -NODES[754](BODY_FORCE_X,0) = 0.000000; -NODES[754](BODY_FORCE_Y,0) = -9.810000; -NODES[754](BODY_FORCE_Z,0) = 0.000000; -NODES[755](BODY_FORCE_X,0) = 0.000000; -NODES[755](BODY_FORCE_Y,0) = -9.810000; -NODES[755](BODY_FORCE_Z,0) = 0.000000; -NODES[756](BODY_FORCE_X,0) = 0.000000; -NODES[756](BODY_FORCE_Y,0) = -9.810000; -NODES[756](BODY_FORCE_Z,0) = 0.000000; -NODES[757](BODY_FORCE_X,0) = 0.000000; -NODES[757](BODY_FORCE_Y,0) = -9.810000; -NODES[757](BODY_FORCE_Z,0) = 0.000000; -NODES[758](BODY_FORCE_X,0) = 0.000000; -NODES[758](BODY_FORCE_Y,0) = -9.810000; -NODES[758](BODY_FORCE_Z,0) = 0.000000; -NODES[759](BODY_FORCE_X,0) = 0.000000; -NODES[759](BODY_FORCE_Y,0) = -9.810000; -NODES[759](BODY_FORCE_Z,0) = 0.000000; -NODES[760](BODY_FORCE_X,0) = 0.000000; -NODES[760](BODY_FORCE_Y,0) = -9.810000; -NODES[760](BODY_FORCE_Z,0) = 0.000000; -NODES[761](BODY_FORCE_X,0) = 0.000000; -NODES[761](BODY_FORCE_Y,0) = -9.810000; -NODES[761](BODY_FORCE_Z,0) = 0.000000; -NODES[762](BODY_FORCE_X,0) = 0.000000; -NODES[762](BODY_FORCE_Y,0) = -9.810000; -NODES[762](BODY_FORCE_Z,0) = 0.000000; -NODES[763](BODY_FORCE_X,0) = 0.000000; -NODES[763](BODY_FORCE_Y,0) = -9.810000; -NODES[763](BODY_FORCE_Z,0) = 0.000000; -NODES[764](BODY_FORCE_X,0) = 0.000000; -NODES[764](BODY_FORCE_Y,0) = -9.810000; -NODES[764](BODY_FORCE_Z,0) = 0.000000; -NODES[765](BODY_FORCE_X,0) = 0.000000; -NODES[765](BODY_FORCE_Y,0) = -9.810000; -NODES[765](BODY_FORCE_Z,0) = 0.000000; -NODES[766](BODY_FORCE_X,0) = 0.000000; -NODES[766](BODY_FORCE_Y,0) = -9.810000; -NODES[766](BODY_FORCE_Z,0) = 0.000000; -NODES[767](BODY_FORCE_X,0) = 0.000000; -NODES[767](BODY_FORCE_Y,0) = -9.810000; -NODES[767](BODY_FORCE_Z,0) = 0.000000; -NODES[768](BODY_FORCE_X,0) = 0.000000; -NODES[768](BODY_FORCE_Y,0) = -9.810000; -NODES[768](BODY_FORCE_Z,0) = 0.000000; -NODES[769](BODY_FORCE_X,0) = 0.000000; -NODES[769](BODY_FORCE_Y,0) = -9.810000; -NODES[769](BODY_FORCE_Z,0) = 0.000000; -NODES[770](BODY_FORCE_X,0) = 0.000000; -NODES[770](BODY_FORCE_Y,0) = -9.810000; -NODES[770](BODY_FORCE_Z,0) = 0.000000; -NODES[771](BODY_FORCE_X,0) = 0.000000; -NODES[771](BODY_FORCE_Y,0) = -9.810000; -NODES[771](BODY_FORCE_Z,0) = 0.000000; -NODES[772](BODY_FORCE_X,0) = 0.000000; -NODES[772](BODY_FORCE_Y,0) = -9.810000; -NODES[772](BODY_FORCE_Z,0) = 0.000000; -NODES[773](BODY_FORCE_X,0) = 0.000000; -NODES[773](BODY_FORCE_Y,0) = -9.810000; -NODES[773](BODY_FORCE_Z,0) = 0.000000; -NODES[774](BODY_FORCE_X,0) = 0.000000; -NODES[774](BODY_FORCE_Y,0) = -9.810000; -NODES[774](BODY_FORCE_Z,0) = 0.000000; -NODES[775](BODY_FORCE_X,0) = 0.000000; -NODES[775](BODY_FORCE_Y,0) = -9.810000; -NODES[775](BODY_FORCE_Z,0) = 0.000000; -NODES[776](BODY_FORCE_X,0) = 0.000000; -NODES[776](BODY_FORCE_Y,0) = -9.810000; -NODES[776](BODY_FORCE_Z,0) = 0.000000; -NODES[777](BODY_FORCE_X,0) = 0.000000; -NODES[777](BODY_FORCE_Y,0) = -9.810000; -NODES[777](BODY_FORCE_Z,0) = 0.000000; -NODES[778](BODY_FORCE_X,0) = 0.000000; -NODES[778](BODY_FORCE_Y,0) = -9.810000; -NODES[778](BODY_FORCE_Z,0) = 0.000000; -NODES[779](BODY_FORCE_X,0) = 0.000000; -NODES[779](BODY_FORCE_Y,0) = -9.810000; -NODES[779](BODY_FORCE_Z,0) = 0.000000; -NODES[780](BODY_FORCE_X,0) = 0.000000; -NODES[780](BODY_FORCE_Y,0) = -9.810000; -NODES[780](BODY_FORCE_Z,0) = 0.000000; -NODES[781](BODY_FORCE_X,0) = 0.000000; -NODES[781](BODY_FORCE_Y,0) = -9.810000; -NODES[781](BODY_FORCE_Z,0) = 0.000000; -NODES[782](BODY_FORCE_X,0) = 0.000000; -NODES[782](BODY_FORCE_Y,0) = -9.810000; -NODES[782](BODY_FORCE_Z,0) = 0.000000; -NODES[783](BODY_FORCE_X,0) = 0.000000; -NODES[783](BODY_FORCE_Y,0) = -9.810000; -NODES[783](BODY_FORCE_Z,0) = 0.000000; -NODES[784](BODY_FORCE_X,0) = 0.000000; -NODES[784](BODY_FORCE_Y,0) = -9.810000; -NODES[784](BODY_FORCE_Z,0) = 0.000000; -NODES[785](BODY_FORCE_X,0) = 0.000000; -NODES[785](BODY_FORCE_Y,0) = -9.810000; -NODES[785](BODY_FORCE_Z,0) = 0.000000; -NODES[786](BODY_FORCE_X,0) = 0.000000; -NODES[786](BODY_FORCE_Y,0) = -9.810000; -NODES[786](BODY_FORCE_Z,0) = 0.000000; -NODES[787](BODY_FORCE_X,0) = 0.000000; -NODES[787](BODY_FORCE_Y,0) = -9.810000; -NODES[787](BODY_FORCE_Z,0) = 0.000000; -NODES[788](BODY_FORCE_X,0) = 0.000000; -NODES[788](BODY_FORCE_Y,0) = -9.810000; -NODES[788](BODY_FORCE_Z,0) = 0.000000; -NODES[789](BODY_FORCE_X,0) = 0.000000; -NODES[789](BODY_FORCE_Y,0) = -9.810000; -NODES[789](BODY_FORCE_Z,0) = 0.000000; -NODES[790](BODY_FORCE_X,0) = 0.000000; -NODES[790](BODY_FORCE_Y,0) = -9.810000; -NODES[790](BODY_FORCE_Z,0) = 0.000000; -NODES[791](BODY_FORCE_X,0) = 0.000000; -NODES[791](BODY_FORCE_Y,0) = -9.810000; -NODES[791](BODY_FORCE_Z,0) = 0.000000; -NODES[792](BODY_FORCE_X,0) = 0.000000; -NODES[792](BODY_FORCE_Y,0) = -9.810000; -NODES[792](BODY_FORCE_Z,0) = 0.000000; -NODES[793](BODY_FORCE_X,0) = 0.000000; -NODES[793](BODY_FORCE_Y,0) = -9.810000; -NODES[793](BODY_FORCE_Z,0) = 0.000000; -NODES[794](BODY_FORCE_X,0) = 0.000000; -NODES[794](BODY_FORCE_Y,0) = -9.810000; -NODES[794](BODY_FORCE_Z,0) = 0.000000; -NODES[795](BODY_FORCE_X,0) = 0.000000; -NODES[795](BODY_FORCE_Y,0) = -9.810000; -NODES[795](BODY_FORCE_Z,0) = 0.000000; -NODES[796](BODY_FORCE_X,0) = 0.000000; -NODES[796](BODY_FORCE_Y,0) = -9.810000; -NODES[796](BODY_FORCE_Z,0) = 0.000000; -NODES[797](BODY_FORCE_X,0) = 0.000000; -NODES[797](BODY_FORCE_Y,0) = -9.810000; -NODES[797](BODY_FORCE_Z,0) = 0.000000; -NODES[798](BODY_FORCE_X,0) = 0.000000; -NODES[798](BODY_FORCE_Y,0) = -9.810000; -NODES[798](BODY_FORCE_Z,0) = 0.000000; -NODES[799](BODY_FORCE_X,0) = 0.000000; -NODES[799](BODY_FORCE_Y,0) = -9.810000; -NODES[799](BODY_FORCE_Z,0) = 0.000000; -NODES[800](BODY_FORCE_X,0) = 0.000000; -NODES[800](BODY_FORCE_Y,0) = -9.810000; -NODES[800](BODY_FORCE_Z,0) = 0.000000; -NODES[801](BODY_FORCE_X,0) = 0.000000; -NODES[801](BODY_FORCE_Y,0) = -9.810000; -NODES[801](BODY_FORCE_Z,0) = 0.000000; -NODES[803](BODY_FORCE_X,0) = 0.000000; -NODES[803](BODY_FORCE_Y,0) = -9.810000; -NODES[803](BODY_FORCE_Z,0) = 0.000000; -NODES[804](BODY_FORCE_X,0) = 0.000000; -NODES[804](BODY_FORCE_Y,0) = -9.810000; -NODES[804](BODY_FORCE_Z,0) = 0.000000; -NODES[805](BODY_FORCE_X,0) = 0.000000; -NODES[805](BODY_FORCE_Y,0) = -9.810000; -NODES[805](BODY_FORCE_Z,0) = 0.000000; -NODES[806](BODY_FORCE_X,0) = 0.000000; -NODES[806](BODY_FORCE_Y,0) = -9.810000; -NODES[806](BODY_FORCE_Z,0) = 0.000000; -NODES[807](BODY_FORCE_X,0) = 0.000000; -NODES[807](BODY_FORCE_Y,0) = -9.810000; -NODES[807](BODY_FORCE_Z,0) = 0.000000; -NODES[808](BODY_FORCE_X,0) = 0.000000; -NODES[808](BODY_FORCE_Y,0) = -9.810000; -NODES[808](BODY_FORCE_Z,0) = 0.000000; -NODES[809](BODY_FORCE_X,0) = 0.000000; -NODES[809](BODY_FORCE_Y,0) = -9.810000; -NODES[809](BODY_FORCE_Z,0) = 0.000000; -NODES[810](BODY_FORCE_X,0) = 0.000000; -NODES[810](BODY_FORCE_Y,0) = -9.810000; -NODES[810](BODY_FORCE_Z,0) = 0.000000; -NODES[811](BODY_FORCE_X,0) = 0.000000; -NODES[811](BODY_FORCE_Y,0) = -9.810000; -NODES[811](BODY_FORCE_Z,0) = 0.000000; -NODES[812](BODY_FORCE_X,0) = 0.000000; -NODES[812](BODY_FORCE_Y,0) = -9.810000; -NODES[812](BODY_FORCE_Z,0) = 0.000000; -NODES[813](BODY_FORCE_X,0) = 0.000000; -NODES[813](BODY_FORCE_Y,0) = -9.810000; -NODES[813](BODY_FORCE_Z,0) = 0.000000; -NODES[814](BODY_FORCE_X,0) = 0.000000; -NODES[814](BODY_FORCE_Y,0) = -9.810000; -NODES[814](BODY_FORCE_Z,0) = 0.000000; -NODES[815](BODY_FORCE_X,0) = 0.000000; -NODES[815](BODY_FORCE_Y,0) = -9.810000; -NODES[815](BODY_FORCE_Z,0) = 0.000000; -NODES[816](BODY_FORCE_X,0) = 0.000000; -NODES[816](BODY_FORCE_Y,0) = -9.810000; -NODES[816](BODY_FORCE_Z,0) = 0.000000; -NODES[817](BODY_FORCE_X,0) = 0.000000; -NODES[817](BODY_FORCE_Y,0) = -9.810000; -NODES[817](BODY_FORCE_Z,0) = 0.000000; -NODES[818](BODY_FORCE_X,0) = 0.000000; -NODES[818](BODY_FORCE_Y,0) = -9.810000; -NODES[818](BODY_FORCE_Z,0) = 0.000000; -NODES[819](BODY_FORCE_X,0) = 0.000000; -NODES[819](BODY_FORCE_Y,0) = -9.810000; -NODES[819](BODY_FORCE_Z,0) = 0.000000; -NODES[820](BODY_FORCE_X,0) = 0.000000; -NODES[820](BODY_FORCE_Y,0) = -9.810000; -NODES[820](BODY_FORCE_Z,0) = 0.000000; -NODES[821](BODY_FORCE_X,0) = 0.000000; -NODES[821](BODY_FORCE_Y,0) = -9.810000; -NODES[821](BODY_FORCE_Z,0) = 0.000000; -NODES[822](BODY_FORCE_X,0) = 0.000000; -NODES[822](BODY_FORCE_Y,0) = -9.810000; -NODES[822](BODY_FORCE_Z,0) = 0.000000; -NODES[823](BODY_FORCE_X,0) = 0.000000; -NODES[823](BODY_FORCE_Y,0) = -9.810000; -NODES[823](BODY_FORCE_Z,0) = 0.000000; -NODES[824](BODY_FORCE_X,0) = 0.000000; -NODES[824](BODY_FORCE_Y,0) = -9.810000; -NODES[824](BODY_FORCE_Z,0) = 0.000000; -NODES[825](BODY_FORCE_X,0) = 0.000000; -NODES[825](BODY_FORCE_Y,0) = -9.810000; -NODES[825](BODY_FORCE_Z,0) = 0.000000; -NODES[826](BODY_FORCE_X,0) = 0.000000; -NODES[826](BODY_FORCE_Y,0) = -9.810000; -NODES[826](BODY_FORCE_Z,0) = 0.000000; -NODES[827](BODY_FORCE_X,0) = 0.000000; -NODES[827](BODY_FORCE_Y,0) = -9.810000; -NODES[827](BODY_FORCE_Z,0) = 0.000000; -NODES[828](BODY_FORCE_X,0) = 0.000000; -NODES[828](BODY_FORCE_Y,0) = -9.810000; -NODES[828](BODY_FORCE_Z,0) = 0.000000; -NODES[829](BODY_FORCE_X,0) = 0.000000; -NODES[829](BODY_FORCE_Y,0) = -9.810000; -NODES[829](BODY_FORCE_Z,0) = 0.000000; -NODES[830](BODY_FORCE_X,0) = 0.000000; -NODES[830](BODY_FORCE_Y,0) = -9.810000; -NODES[830](BODY_FORCE_Z,0) = 0.000000; -NODES[831](BODY_FORCE_X,0) = 0.000000; -NODES[831](BODY_FORCE_Y,0) = -9.810000; -NODES[831](BODY_FORCE_Z,0) = 0.000000; -NODES[832](BODY_FORCE_X,0) = 0.000000; -NODES[832](BODY_FORCE_Y,0) = -9.810000; -NODES[832](BODY_FORCE_Z,0) = 0.000000; -NODES[833](BODY_FORCE_X,0) = 0.000000; -NODES[833](BODY_FORCE_Y,0) = -9.810000; -NODES[833](BODY_FORCE_Z,0) = 0.000000; -NODES[834](BODY_FORCE_X,0) = 0.000000; -NODES[834](BODY_FORCE_Y,0) = -9.810000; -NODES[834](BODY_FORCE_Z,0) = 0.000000; -NODES[835](BODY_FORCE_X,0) = 0.000000; -NODES[835](BODY_FORCE_Y,0) = -9.810000; -NODES[835](BODY_FORCE_Z,0) = 0.000000; -NODES[836](BODY_FORCE_X,0) = 0.000000; -NODES[836](BODY_FORCE_Y,0) = -9.810000; -NODES[836](BODY_FORCE_Z,0) = 0.000000; -NODES[837](BODY_FORCE_X,0) = 0.000000; -NODES[837](BODY_FORCE_Y,0) = -9.810000; -NODES[837](BODY_FORCE_Z,0) = 0.000000; -NODES[838](BODY_FORCE_X,0) = 0.000000; -NODES[838](BODY_FORCE_Y,0) = -9.810000; -NODES[838](BODY_FORCE_Z,0) = 0.000000; -NODES[839](BODY_FORCE_X,0) = 0.000000; -NODES[839](BODY_FORCE_Y,0) = -9.810000; -NODES[839](BODY_FORCE_Z,0) = 0.000000; -NODES[840](BODY_FORCE_X,0) = 0.000000; -NODES[840](BODY_FORCE_Y,0) = -9.810000; -NODES[840](BODY_FORCE_Z,0) = 0.000000; -NODES[841](BODY_FORCE_X,0) = 0.000000; -NODES[841](BODY_FORCE_Y,0) = -9.810000; -NODES[841](BODY_FORCE_Z,0) = 0.000000; -NODES[842](BODY_FORCE_X,0) = 0.000000; -NODES[842](BODY_FORCE_Y,0) = -9.810000; -NODES[842](BODY_FORCE_Z,0) = 0.000000; -NODES[843](BODY_FORCE_X,0) = 0.000000; -NODES[843](BODY_FORCE_Y,0) = -9.810000; -NODES[843](BODY_FORCE_Z,0) = 0.000000; -NODES[844](BODY_FORCE_X,0) = 0.000000; -NODES[844](BODY_FORCE_Y,0) = -9.810000; -NODES[844](BODY_FORCE_Z,0) = 0.000000; -NODES[845](BODY_FORCE_X,0) = 0.000000; -NODES[845](BODY_FORCE_Y,0) = -9.810000; -NODES[845](BODY_FORCE_Z,0) = 0.000000; -NODES[846](BODY_FORCE_X,0) = 0.000000; -NODES[846](BODY_FORCE_Y,0) = -9.810000; -NODES[846](BODY_FORCE_Z,0) = 0.000000; -NODES[847](BODY_FORCE_X,0) = 0.000000; -NODES[847](BODY_FORCE_Y,0) = -9.810000; -NODES[847](BODY_FORCE_Z,0) = 0.000000; -NODES[848](BODY_FORCE_X,0) = 0.000000; -NODES[848](BODY_FORCE_Y,0) = -9.810000; -NODES[848](BODY_FORCE_Z,0) = 0.000000; -NODES[849](BODY_FORCE_X,0) = 0.000000; -NODES[849](BODY_FORCE_Y,0) = -9.810000; -NODES[849](BODY_FORCE_Z,0) = 0.000000; -NODES[850](BODY_FORCE_X,0) = 0.000000; -NODES[850](BODY_FORCE_Y,0) = -9.810000; -NODES[850](BODY_FORCE_Z,0) = 0.000000; -NODES[851](BODY_FORCE_X,0) = 0.000000; -NODES[851](BODY_FORCE_Y,0) = -9.810000; -NODES[851](BODY_FORCE_Z,0) = 0.000000; -NODES[852](BODY_FORCE_X,0) = 0.000000; -NODES[852](BODY_FORCE_Y,0) = -9.810000; -NODES[852](BODY_FORCE_Z,0) = 0.000000; -NODES[853](BODY_FORCE_X,0) = 0.000000; -NODES[853](BODY_FORCE_Y,0) = -9.810000; -NODES[853](BODY_FORCE_Z,0) = 0.000000; -NODES[854](BODY_FORCE_X,0) = 0.000000; -NODES[854](BODY_FORCE_Y,0) = -9.810000; -NODES[854](BODY_FORCE_Z,0) = 0.000000; -NODES[855](BODY_FORCE_X,0) = 0.000000; -NODES[855](BODY_FORCE_Y,0) = -9.810000; -NODES[855](BODY_FORCE_Z,0) = 0.000000; -NODES[856](BODY_FORCE_X,0) = 0.000000; -NODES[856](BODY_FORCE_Y,0) = -9.810000; -NODES[856](BODY_FORCE_Z,0) = 0.000000; -NODES[857](BODY_FORCE_X,0) = 0.000000; -NODES[857](BODY_FORCE_Y,0) = -9.810000; -NODES[857](BODY_FORCE_Z,0) = 0.000000; -NODES[858](BODY_FORCE_X,0) = 0.000000; -NODES[858](BODY_FORCE_Y,0) = -9.810000; -NODES[858](BODY_FORCE_Z,0) = 0.000000; -NODES[859](BODY_FORCE_X,0) = 0.000000; -NODES[859](BODY_FORCE_Y,0) = -9.810000; -NODES[859](BODY_FORCE_Z,0) = 0.000000; -NODES[860](BODY_FORCE_X,0) = 0.000000; -NODES[860](BODY_FORCE_Y,0) = -9.810000; -NODES[860](BODY_FORCE_Z,0) = 0.000000; -NODES[861](BODY_FORCE_X,0) = 0.000000; -NODES[861](BODY_FORCE_Y,0) = -9.810000; -NODES[861](BODY_FORCE_Z,0) = 0.000000; -NODES[862](BODY_FORCE_X,0) = 0.000000; -NODES[862](BODY_FORCE_Y,0) = -9.810000; -NODES[862](BODY_FORCE_Z,0) = 0.000000; -NODES[863](BODY_FORCE_X,0) = 0.000000; -NODES[863](BODY_FORCE_Y,0) = -9.810000; -NODES[863](BODY_FORCE_Z,0) = 0.000000; -NODES[864](BODY_FORCE_X,0) = 0.000000; -NODES[864](BODY_FORCE_Y,0) = -9.810000; -NODES[864](BODY_FORCE_Z,0) = 0.000000; -NODES[865](BODY_FORCE_X,0) = 0.000000; -NODES[865](BODY_FORCE_Y,0) = -9.810000; -NODES[865](BODY_FORCE_Z,0) = 0.000000; -NODES[866](BODY_FORCE_X,0) = 0.000000; -NODES[866](BODY_FORCE_Y,0) = -9.810000; -NODES[866](BODY_FORCE_Z,0) = 0.000000; -NODES[868](BODY_FORCE_X,0) = 0.000000; -NODES[868](BODY_FORCE_Y,0) = -9.810000; -NODES[868](BODY_FORCE_Z,0) = 0.000000; -NODES[869](BODY_FORCE_X,0) = 0.000000; -NODES[869](BODY_FORCE_Y,0) = -9.810000; -NODES[869](BODY_FORCE_Z,0) = 0.000000; -NODES[870](BODY_FORCE_X,0) = 0.000000; -NODES[870](BODY_FORCE_Y,0) = -9.810000; -NODES[870](BODY_FORCE_Z,0) = 0.000000; -NODES[871](BODY_FORCE_X,0) = 0.000000; -NODES[871](BODY_FORCE_Y,0) = -9.810000; -NODES[871](BODY_FORCE_Z,0) = 0.000000; -NODES[872](BODY_FORCE_X,0) = 0.000000; -NODES[872](BODY_FORCE_Y,0) = -9.810000; -NODES[872](BODY_FORCE_Z,0) = 0.000000; -NODES[873](BODY_FORCE_X,0) = 0.000000; -NODES[873](BODY_FORCE_Y,0) = -9.810000; -NODES[873](BODY_FORCE_Z,0) = 0.000000; -NODES[874](BODY_FORCE_X,0) = 0.000000; -NODES[874](BODY_FORCE_Y,0) = -9.810000; -NODES[874](BODY_FORCE_Z,0) = 0.000000; -NODES[875](BODY_FORCE_X,0) = 0.000000; -NODES[875](BODY_FORCE_Y,0) = -9.810000; -NODES[875](BODY_FORCE_Z,0) = 0.000000; -NODES[876](BODY_FORCE_X,0) = 0.000000; -NODES[876](BODY_FORCE_Y,0) = -9.810000; -NODES[876](BODY_FORCE_Z,0) = 0.000000; -NODES[877](BODY_FORCE_X,0) = 0.000000; -NODES[877](BODY_FORCE_Y,0) = -9.810000; -NODES[877](BODY_FORCE_Z,0) = 0.000000; -NODES[878](BODY_FORCE_X,0) = 0.000000; -NODES[878](BODY_FORCE_Y,0) = -9.810000; -NODES[878](BODY_FORCE_Z,0) = 0.000000; -NODES[879](BODY_FORCE_X,0) = 0.000000; -NODES[879](BODY_FORCE_Y,0) = -9.810000; -NODES[879](BODY_FORCE_Z,0) = 0.000000; -NODES[880](BODY_FORCE_X,0) = 0.000000; -NODES[880](BODY_FORCE_Y,0) = -9.810000; -NODES[880](BODY_FORCE_Z,0) = 0.000000; -NODES[881](BODY_FORCE_X,0) = 0.000000; -NODES[881](BODY_FORCE_Y,0) = -9.810000; -NODES[881](BODY_FORCE_Z,0) = 0.000000; -NODES[882](BODY_FORCE_X,0) = 0.000000; -NODES[882](BODY_FORCE_Y,0) = -9.810000; -NODES[882](BODY_FORCE_Z,0) = 0.000000; -NODES[883](BODY_FORCE_X,0) = 0.000000; -NODES[883](BODY_FORCE_Y,0) = -9.810000; -NODES[883](BODY_FORCE_Z,0) = 0.000000; -NODES[884](BODY_FORCE_X,0) = 0.000000; -NODES[884](BODY_FORCE_Y,0) = -9.810000; -NODES[884](BODY_FORCE_Z,0) = 0.000000; -NODES[885](BODY_FORCE_X,0) = 0.000000; -NODES[885](BODY_FORCE_Y,0) = -9.810000; -NODES[885](BODY_FORCE_Z,0) = 0.000000; -NODES[886](BODY_FORCE_X,0) = 0.000000; -NODES[886](BODY_FORCE_Y,0) = -9.810000; -NODES[886](BODY_FORCE_Z,0) = 0.000000; -NODES[887](BODY_FORCE_X,0) = 0.000000; -NODES[887](BODY_FORCE_Y,0) = -9.810000; -NODES[887](BODY_FORCE_Z,0) = 0.000000; -NODES[888](BODY_FORCE_X,0) = 0.000000; -NODES[888](BODY_FORCE_Y,0) = -9.810000; -NODES[888](BODY_FORCE_Z,0) = 0.000000; -NODES[889](BODY_FORCE_X,0) = 0.000000; -NODES[889](BODY_FORCE_Y,0) = -9.810000; -NODES[889](BODY_FORCE_Z,0) = 0.000000; -NODES[890](BODY_FORCE_X,0) = 0.000000; -NODES[890](BODY_FORCE_Y,0) = -9.810000; -NODES[890](BODY_FORCE_Z,0) = 0.000000; -NODES[891](BODY_FORCE_X,0) = 0.000000; -NODES[891](BODY_FORCE_Y,0) = -9.810000; -NODES[891](BODY_FORCE_Z,0) = 0.000000; -NODES[892](BODY_FORCE_X,0) = 0.000000; -NODES[892](BODY_FORCE_Y,0) = -9.810000; -NODES[892](BODY_FORCE_Z,0) = 0.000000; -NODES[893](BODY_FORCE_X,0) = 0.000000; -NODES[893](BODY_FORCE_Y,0) = -9.810000; -NODES[893](BODY_FORCE_Z,0) = 0.000000; -NODES[894](BODY_FORCE_X,0) = 0.000000; -NODES[894](BODY_FORCE_Y,0) = -9.810000; -NODES[894](BODY_FORCE_Z,0) = 0.000000; -NODES[895](BODY_FORCE_X,0) = 0.000000; -NODES[895](BODY_FORCE_Y,0) = -9.810000; -NODES[895](BODY_FORCE_Z,0) = 0.000000; -NODES[896](BODY_FORCE_X,0) = 0.000000; -NODES[896](BODY_FORCE_Y,0) = -9.810000; -NODES[896](BODY_FORCE_Z,0) = 0.000000; -NODES[897](BODY_FORCE_X,0) = 0.000000; -NODES[897](BODY_FORCE_Y,0) = -9.810000; -NODES[897](BODY_FORCE_Z,0) = 0.000000; -NODES[898](BODY_FORCE_X,0) = 0.000000; -NODES[898](BODY_FORCE_Y,0) = -9.810000; -NODES[898](BODY_FORCE_Z,0) = 0.000000; -NODES[899](BODY_FORCE_X,0) = 0.000000; -NODES[899](BODY_FORCE_Y,0) = -9.810000; -NODES[899](BODY_FORCE_Z,0) = 0.000000; -NODES[900](BODY_FORCE_X,0) = 0.000000; -NODES[900](BODY_FORCE_Y,0) = -9.810000; -NODES[900](BODY_FORCE_Z,0) = 0.000000; -NODES[901](BODY_FORCE_X,0) = 0.000000; -NODES[901](BODY_FORCE_Y,0) = -9.810000; -NODES[901](BODY_FORCE_Z,0) = 0.000000; -NODES[902](BODY_FORCE_X,0) = 0.000000; -NODES[902](BODY_FORCE_Y,0) = -9.810000; -NODES[902](BODY_FORCE_Z,0) = 0.000000; -NODES[903](BODY_FORCE_X,0) = 0.000000; -NODES[903](BODY_FORCE_Y,0) = -9.810000; -NODES[903](BODY_FORCE_Z,0) = 0.000000; -NODES[904](BODY_FORCE_X,0) = 0.000000; -NODES[904](BODY_FORCE_Y,0) = -9.810000; -NODES[904](BODY_FORCE_Z,0) = 0.000000; -NODES[905](BODY_FORCE_X,0) = 0.000000; -NODES[905](BODY_FORCE_Y,0) = -9.810000; -NODES[905](BODY_FORCE_Z,0) = 0.000000; -NODES[906](BODY_FORCE_X,0) = 0.000000; -NODES[906](BODY_FORCE_Y,0) = -9.810000; -NODES[906](BODY_FORCE_Z,0) = 0.000000; -NODES[907](BODY_FORCE_X,0) = 0.000000; -NODES[907](BODY_FORCE_Y,0) = -9.810000; -NODES[907](BODY_FORCE_Z,0) = 0.000000; -NODES[908](BODY_FORCE_X,0) = 0.000000; -NODES[908](BODY_FORCE_Y,0) = -9.810000; -NODES[908](BODY_FORCE_Z,0) = 0.000000; -NODES[909](BODY_FORCE_X,0) = 0.000000; -NODES[909](BODY_FORCE_Y,0) = -9.810000; -NODES[909](BODY_FORCE_Z,0) = 0.000000; -NODES[910](BODY_FORCE_X,0) = 0.000000; -NODES[910](BODY_FORCE_Y,0) = -9.810000; -NODES[910](BODY_FORCE_Z,0) = 0.000000; -NODES[911](BODY_FORCE_X,0) = 0.000000; -NODES[911](BODY_FORCE_Y,0) = -9.810000; -NODES[911](BODY_FORCE_Z,0) = 0.000000; -NODES[912](BODY_FORCE_X,0) = 0.000000; -NODES[912](BODY_FORCE_Y,0) = -9.810000; -NODES[912](BODY_FORCE_Z,0) = 0.000000; -NODES[913](BODY_FORCE_X,0) = 0.000000; -NODES[913](BODY_FORCE_Y,0) = -9.810000; -NODES[913](BODY_FORCE_Z,0) = 0.000000; -NODES[914](BODY_FORCE_X,0) = 0.000000; -NODES[914](BODY_FORCE_Y,0) = -9.810000; -NODES[914](BODY_FORCE_Z,0) = 0.000000; -NODES[915](BODY_FORCE_X,0) = 0.000000; -NODES[915](BODY_FORCE_Y,0) = -9.810000; -NODES[915](BODY_FORCE_Z,0) = 0.000000; -NODES[916](BODY_FORCE_X,0) = 0.000000; -NODES[916](BODY_FORCE_Y,0) = -9.810000; -NODES[916](BODY_FORCE_Z,0) = 0.000000; -NODES[917](BODY_FORCE_X,0) = 0.000000; -NODES[917](BODY_FORCE_Y,0) = -9.810000; -NODES[917](BODY_FORCE_Z,0) = 0.000000; -NODES[918](BODY_FORCE_X,0) = 0.000000; -NODES[918](BODY_FORCE_Y,0) = -9.810000; -NODES[918](BODY_FORCE_Z,0) = 0.000000; -NODES[919](BODY_FORCE_X,0) = 0.000000; -NODES[919](BODY_FORCE_Y,0) = -9.810000; -NODES[919](BODY_FORCE_Z,0) = 0.000000; -NODES[920](BODY_FORCE_X,0) = 0.000000; -NODES[920](BODY_FORCE_Y,0) = -9.810000; -NODES[920](BODY_FORCE_Z,0) = 0.000000; -NODES[921](BODY_FORCE_X,0) = 0.000000; -NODES[921](BODY_FORCE_Y,0) = -9.810000; -NODES[921](BODY_FORCE_Z,0) = 0.000000; -NODES[922](BODY_FORCE_X,0) = 0.000000; -NODES[922](BODY_FORCE_Y,0) = -9.810000; -NODES[922](BODY_FORCE_Z,0) = 0.000000; -NODES[923](BODY_FORCE_X,0) = 0.000000; -NODES[923](BODY_FORCE_Y,0) = -9.810000; -NODES[923](BODY_FORCE_Z,0) = 0.000000; -NODES[924](BODY_FORCE_X,0) = 0.000000; -NODES[924](BODY_FORCE_Y,0) = -9.810000; -NODES[924](BODY_FORCE_Z,0) = 0.000000; -NODES[925](BODY_FORCE_X,0) = 0.000000; -NODES[925](BODY_FORCE_Y,0) = -9.810000; -NODES[925](BODY_FORCE_Z,0) = 0.000000; -NODES[926](BODY_FORCE_X,0) = 0.000000; -NODES[926](BODY_FORCE_Y,0) = -9.810000; -NODES[926](BODY_FORCE_Z,0) = 0.000000; -NODES[927](BODY_FORCE_X,0) = 0.000000; -NODES[927](BODY_FORCE_Y,0) = -9.810000; -NODES[927](BODY_FORCE_Z,0) = 0.000000; -NODES[928](BODY_FORCE_X,0) = 0.000000; -NODES[928](BODY_FORCE_Y,0) = -9.810000; -NODES[928](BODY_FORCE_Z,0) = 0.000000; -NODES[929](BODY_FORCE_X,0) = 0.000000; -NODES[929](BODY_FORCE_Y,0) = -9.810000; -NODES[929](BODY_FORCE_Z,0) = 0.000000; -NODES[930](BODY_FORCE_X,0) = 0.000000; -NODES[930](BODY_FORCE_Y,0) = -9.810000; -NODES[930](BODY_FORCE_Z,0) = 0.000000; -NODES[931](BODY_FORCE_X,0) = 0.000000; -NODES[931](BODY_FORCE_Y,0) = -9.810000; -NODES[931](BODY_FORCE_Z,0) = 0.000000; -NODES[932](BODY_FORCE_X,0) = 0.000000; -NODES[932](BODY_FORCE_Y,0) = -9.810000; -NODES[932](BODY_FORCE_Z,0) = 0.000000; -NODES[933](BODY_FORCE_X,0) = 0.000000; -NODES[933](BODY_FORCE_Y,0) = -9.810000; -NODES[933](BODY_FORCE_Z,0) = 0.000000; -NODES[934](BODY_FORCE_X,0) = 0.000000; -NODES[934](BODY_FORCE_Y,0) = -9.810000; -NODES[934](BODY_FORCE_Z,0) = 0.000000; -NODES[935](BODY_FORCE_X,0) = 0.000000; -NODES[935](BODY_FORCE_Y,0) = -9.810000; -NODES[935](BODY_FORCE_Z,0) = 0.000000; -NODES[936](BODY_FORCE_X,0) = 0.000000; -NODES[936](BODY_FORCE_Y,0) = -9.810000; -NODES[936](BODY_FORCE_Z,0) = 0.000000; -NODES[937](BODY_FORCE_X,0) = 0.000000; -NODES[937](BODY_FORCE_Y,0) = -9.810000; -NODES[937](BODY_FORCE_Z,0) = 0.000000; -NODES[939](BODY_FORCE_X,0) = 0.000000; -NODES[939](BODY_FORCE_Y,0) = -9.810000; -NODES[939](BODY_FORCE_Z,0) = 0.000000; -NODES[940](BODY_FORCE_X,0) = 0.000000; -NODES[940](BODY_FORCE_Y,0) = -9.810000; -NODES[940](BODY_FORCE_Z,0) = 0.000000; -NODES[941](BODY_FORCE_X,0) = 0.000000; -NODES[941](BODY_FORCE_Y,0) = -9.810000; -NODES[941](BODY_FORCE_Z,0) = 0.000000; -NODES[942](BODY_FORCE_X,0) = 0.000000; -NODES[942](BODY_FORCE_Y,0) = -9.810000; -NODES[942](BODY_FORCE_Z,0) = 0.000000; -NODES[943](BODY_FORCE_X,0) = 0.000000; -NODES[943](BODY_FORCE_Y,0) = -9.810000; -NODES[943](BODY_FORCE_Z,0) = 0.000000; -NODES[944](BODY_FORCE_X,0) = 0.000000; -NODES[944](BODY_FORCE_Y,0) = -9.810000; -NODES[944](BODY_FORCE_Z,0) = 0.000000; -NODES[945](BODY_FORCE_X,0) = 0.000000; -NODES[945](BODY_FORCE_Y,0) = -9.810000; -NODES[945](BODY_FORCE_Z,0) = 0.000000; -NODES[946](BODY_FORCE_X,0) = 0.000000; -NODES[946](BODY_FORCE_Y,0) = -9.810000; -NODES[946](BODY_FORCE_Z,0) = 0.000000; -NODES[947](BODY_FORCE_X,0) = 0.000000; -NODES[947](BODY_FORCE_Y,0) = -9.810000; -NODES[947](BODY_FORCE_Z,0) = 0.000000; -NODES[948](BODY_FORCE_X,0) = 0.000000; -NODES[948](BODY_FORCE_Y,0) = -9.810000; -NODES[948](BODY_FORCE_Z,0) = 0.000000; -NODES[949](BODY_FORCE_X,0) = 0.000000; -NODES[949](BODY_FORCE_Y,0) = -9.810000; -NODES[949](BODY_FORCE_Z,0) = 0.000000; -NODES[950](BODY_FORCE_X,0) = 0.000000; -NODES[950](BODY_FORCE_Y,0) = -9.810000; -NODES[950](BODY_FORCE_Z,0) = 0.000000; -NODES[951](BODY_FORCE_X,0) = 0.000000; -NODES[951](BODY_FORCE_Y,0) = -9.810000; -NODES[951](BODY_FORCE_Z,0) = 0.000000; -NODES[952](BODY_FORCE_X,0) = 0.000000; -NODES[952](BODY_FORCE_Y,0) = -9.810000; -NODES[952](BODY_FORCE_Z,0) = 0.000000; -NODES[953](BODY_FORCE_X,0) = 0.000000; -NODES[953](BODY_FORCE_Y,0) = -9.810000; -NODES[953](BODY_FORCE_Z,0) = 0.000000; -NODES[954](BODY_FORCE_X,0) = 0.000000; -NODES[954](BODY_FORCE_Y,0) = -9.810000; -NODES[954](BODY_FORCE_Z,0) = 0.000000; -NODES[955](BODY_FORCE_X,0) = 0.000000; -NODES[955](BODY_FORCE_Y,0) = -9.810000; -NODES[955](BODY_FORCE_Z,0) = 0.000000; -NODES[956](BODY_FORCE_X,0) = 0.000000; -NODES[956](BODY_FORCE_Y,0) = -9.810000; -NODES[956](BODY_FORCE_Z,0) = 0.000000; -NODES[957](BODY_FORCE_X,0) = 0.000000; -NODES[957](BODY_FORCE_Y,0) = -9.810000; -NODES[957](BODY_FORCE_Z,0) = 0.000000; -NODES[958](BODY_FORCE_X,0) = 0.000000; -NODES[958](BODY_FORCE_Y,0) = -9.810000; -NODES[958](BODY_FORCE_Z,0) = 0.000000; -NODES[959](BODY_FORCE_X,0) = 0.000000; -NODES[959](BODY_FORCE_Y,0) = -9.810000; -NODES[959](BODY_FORCE_Z,0) = 0.000000; -NODES[960](BODY_FORCE_X,0) = 0.000000; -NODES[960](BODY_FORCE_Y,0) = -9.810000; -NODES[960](BODY_FORCE_Z,0) = 0.000000; -NODES[961](BODY_FORCE_X,0) = 0.000000; -NODES[961](BODY_FORCE_Y,0) = -9.810000; -NODES[961](BODY_FORCE_Z,0) = 0.000000; -NODES[962](BODY_FORCE_X,0) = 0.000000; -NODES[962](BODY_FORCE_Y,0) = -9.810000; -NODES[962](BODY_FORCE_Z,0) = 0.000000; -NODES[963](BODY_FORCE_X,0) = 0.000000; -NODES[963](BODY_FORCE_Y,0) = -9.810000; -NODES[963](BODY_FORCE_Z,0) = 0.000000; -NODES[964](BODY_FORCE_X,0) = 0.000000; -NODES[964](BODY_FORCE_Y,0) = -9.810000; -NODES[964](BODY_FORCE_Z,0) = 0.000000; -NODES[965](BODY_FORCE_X,0) = 0.000000; -NODES[965](BODY_FORCE_Y,0) = -9.810000; -NODES[965](BODY_FORCE_Z,0) = 0.000000; -NODES[966](BODY_FORCE_X,0) = 0.000000; -NODES[966](BODY_FORCE_Y,0) = -9.810000; -NODES[966](BODY_FORCE_Z,0) = 0.000000; -NODES[967](BODY_FORCE_X,0) = 0.000000; -NODES[967](BODY_FORCE_Y,0) = -9.810000; -NODES[967](BODY_FORCE_Z,0) = 0.000000; -NODES[968](BODY_FORCE_X,0) = 0.000000; -NODES[968](BODY_FORCE_Y,0) = -9.810000; -NODES[968](BODY_FORCE_Z,0) = 0.000000; -NODES[969](BODY_FORCE_X,0) = 0.000000; -NODES[969](BODY_FORCE_Y,0) = -9.810000; -NODES[969](BODY_FORCE_Z,0) = 0.000000; -NODES[970](BODY_FORCE_X,0) = 0.000000; -NODES[970](BODY_FORCE_Y,0) = -9.810000; -NODES[970](BODY_FORCE_Z,0) = 0.000000; -NODES[971](BODY_FORCE_X,0) = 0.000000; -NODES[971](BODY_FORCE_Y,0) = -9.810000; -NODES[971](BODY_FORCE_Z,0) = 0.000000; -NODES[972](BODY_FORCE_X,0) = 0.000000; -NODES[972](BODY_FORCE_Y,0) = -9.810000; -NODES[972](BODY_FORCE_Z,0) = 0.000000; -NODES[973](BODY_FORCE_X,0) = 0.000000; -NODES[973](BODY_FORCE_Y,0) = -9.810000; -NODES[973](BODY_FORCE_Z,0) = 0.000000; -NODES[974](BODY_FORCE_X,0) = 0.000000; -NODES[974](BODY_FORCE_Y,0) = -9.810000; -NODES[974](BODY_FORCE_Z,0) = 0.000000; -NODES[975](BODY_FORCE_X,0) = 0.000000; -NODES[975](BODY_FORCE_Y,0) = -9.810000; -NODES[975](BODY_FORCE_Z,0) = 0.000000; -NODES[976](BODY_FORCE_X,0) = 0.000000; -NODES[976](BODY_FORCE_Y,0) = -9.810000; -NODES[976](BODY_FORCE_Z,0) = 0.000000; -NODES[977](BODY_FORCE_X,0) = 0.000000; -NODES[977](BODY_FORCE_Y,0) = -9.810000; -NODES[977](BODY_FORCE_Z,0) = 0.000000; -NODES[978](BODY_FORCE_X,0) = 0.000000; -NODES[978](BODY_FORCE_Y,0) = -9.810000; -NODES[978](BODY_FORCE_Z,0) = 0.000000; -NODES[979](BODY_FORCE_X,0) = 0.000000; -NODES[979](BODY_FORCE_Y,0) = -9.810000; -NODES[979](BODY_FORCE_Z,0) = 0.000000; -NODES[980](BODY_FORCE_X,0) = 0.000000; -NODES[980](BODY_FORCE_Y,0) = -9.810000; -NODES[980](BODY_FORCE_Z,0) = 0.000000; -NODES[981](BODY_FORCE_X,0) = 0.000000; -NODES[981](BODY_FORCE_Y,0) = -9.810000; -NODES[981](BODY_FORCE_Z,0) = 0.000000; -NODES[982](BODY_FORCE_X,0) = 0.000000; -NODES[982](BODY_FORCE_Y,0) = -9.810000; -NODES[982](BODY_FORCE_Z,0) = 0.000000; -NODES[983](BODY_FORCE_X,0) = 0.000000; -NODES[983](BODY_FORCE_Y,0) = -9.810000; -NODES[983](BODY_FORCE_Z,0) = 0.000000; -NODES[984](BODY_FORCE_X,0) = 0.000000; -NODES[984](BODY_FORCE_Y,0) = -9.810000; -NODES[984](BODY_FORCE_Z,0) = 0.000000; -NODES[985](BODY_FORCE_X,0) = 0.000000; -NODES[985](BODY_FORCE_Y,0) = -9.810000; -NODES[985](BODY_FORCE_Z,0) = 0.000000; -NODES[986](BODY_FORCE_X,0) = 0.000000; -NODES[986](BODY_FORCE_Y,0) = -9.810000; -NODES[986](BODY_FORCE_Z,0) = 0.000000; -NODES[987](BODY_FORCE_X,0) = 0.000000; -NODES[987](BODY_FORCE_Y,0) = -9.810000; -NODES[987](BODY_FORCE_Z,0) = 0.000000; -NODES[988](BODY_FORCE_X,0) = 0.000000; -NODES[988](BODY_FORCE_Y,0) = -9.810000; -NODES[988](BODY_FORCE_Z,0) = 0.000000; -NODES[989](BODY_FORCE_X,0) = 0.000000; -NODES[989](BODY_FORCE_Y,0) = -9.810000; -NODES[989](BODY_FORCE_Z,0) = 0.000000; -NODES[990](BODY_FORCE_X,0) = 0.000000; -NODES[990](BODY_FORCE_Y,0) = -9.810000; -NODES[990](BODY_FORCE_Z,0) = 0.000000; -NODES[991](BODY_FORCE_X,0) = 0.000000; -NODES[991](BODY_FORCE_Y,0) = -9.810000; -NODES[991](BODY_FORCE_Z,0) = 0.000000; -NODES[992](BODY_FORCE_X,0) = 0.000000; -NODES[992](BODY_FORCE_Y,0) = -9.810000; -NODES[992](BODY_FORCE_Z,0) = 0.000000; -NODES[993](BODY_FORCE_X,0) = 0.000000; -NODES[993](BODY_FORCE_Y,0) = -9.810000; -NODES[993](BODY_FORCE_Z,0) = 0.000000; -NODES[994](BODY_FORCE_X,0) = 0.000000; -NODES[994](BODY_FORCE_Y,0) = -9.810000; -NODES[994](BODY_FORCE_Z,0) = 0.000000; -NODES[995](BODY_FORCE_X,0) = 0.000000; -NODES[995](BODY_FORCE_Y,0) = -9.810000; -NODES[995](BODY_FORCE_Z,0) = 0.000000; -NODES[996](BODY_FORCE_X,0) = 0.000000; -NODES[996](BODY_FORCE_Y,0) = -9.810000; -NODES[996](BODY_FORCE_Z,0) = 0.000000; -NODES[997](BODY_FORCE_X,0) = 0.000000; -NODES[997](BODY_FORCE_Y,0) = -9.810000; -NODES[997](BODY_FORCE_Z,0) = 0.000000; -NODES[998](BODY_FORCE_X,0) = 0.000000; -NODES[998](BODY_FORCE_Y,0) = -9.810000; -NODES[998](BODY_FORCE_Z,0) = 0.000000; -NODES[999](BODY_FORCE_X,0) = 0.000000; -NODES[999](BODY_FORCE_Y,0) = -9.810000; -NODES[999](BODY_FORCE_Z,0) = 0.000000; -NODES[1000](BODY_FORCE_X,0) = 0.000000; -NODES[1000](BODY_FORCE_Y,0) = -9.810000; -NODES[1000](BODY_FORCE_Z,0) = 0.000000; -NODES[1001](BODY_FORCE_X,0) = 0.000000; -NODES[1001](BODY_FORCE_Y,0) = -9.810000; -NODES[1001](BODY_FORCE_Z,0) = 0.000000; -NODES[1002](BODY_FORCE_X,0) = 0.000000; -NODES[1002](BODY_FORCE_Y,0) = -9.810000; -NODES[1002](BODY_FORCE_Z,0) = 0.000000; -NODES[1003](BODY_FORCE_X,0) = 0.000000; -NODES[1003](BODY_FORCE_Y,0) = -9.810000; -NODES[1003](BODY_FORCE_Z,0) = 0.000000; -NODES[1004](BODY_FORCE_X,0) = 0.000000; -NODES[1004](BODY_FORCE_Y,0) = -9.810000; -NODES[1004](BODY_FORCE_Z,0) = 0.000000; -NODES[1005](BODY_FORCE_X,0) = 0.000000; -NODES[1005](BODY_FORCE_Y,0) = -9.810000; -NODES[1005](BODY_FORCE_Z,0) = 0.000000; -NODES[1006](BODY_FORCE_X,0) = 0.000000; -NODES[1006](BODY_FORCE_Y,0) = -9.810000; -NODES[1006](BODY_FORCE_Z,0) = 0.000000; -NODES[1007](BODY_FORCE_X,0) = 0.000000; -NODES[1007](BODY_FORCE_Y,0) = -9.810000; -NODES[1007](BODY_FORCE_Z,0) = 0.000000; -NODES[1008](BODY_FORCE_X,0) = 0.000000; -NODES[1008](BODY_FORCE_Y,0) = -9.810000; -NODES[1008](BODY_FORCE_Z,0) = 0.000000; -NODES[1010](BODY_FORCE_X,0) = 0.000000; -NODES[1010](BODY_FORCE_Y,0) = -9.810000; -NODES[1010](BODY_FORCE_Z,0) = 0.000000; -NODES[1011](BODY_FORCE_X,0) = 0.000000; -NODES[1011](BODY_FORCE_Y,0) = -9.810000; -NODES[1011](BODY_FORCE_Z,0) = 0.000000; -NODES[1012](BODY_FORCE_X,0) = 0.000000; -NODES[1012](BODY_FORCE_Y,0) = -9.810000; -NODES[1012](BODY_FORCE_Z,0) = 0.000000; -NODES[1013](BODY_FORCE_X,0) = 0.000000; -NODES[1013](BODY_FORCE_Y,0) = -9.810000; -NODES[1013](BODY_FORCE_Z,0) = 0.000000; -NODES[1014](BODY_FORCE_X,0) = 0.000000; -NODES[1014](BODY_FORCE_Y,0) = -9.810000; -NODES[1014](BODY_FORCE_Z,0) = 0.000000; -NODES[1015](BODY_FORCE_X,0) = 0.000000; -NODES[1015](BODY_FORCE_Y,0) = -9.810000; -NODES[1015](BODY_FORCE_Z,0) = 0.000000; -NODES[1016](BODY_FORCE_X,0) = 0.000000; -NODES[1016](BODY_FORCE_Y,0) = -9.810000; -NODES[1016](BODY_FORCE_Z,0) = 0.000000; -NODES[1017](BODY_FORCE_X,0) = 0.000000; -NODES[1017](BODY_FORCE_Y,0) = -9.810000; -NODES[1017](BODY_FORCE_Z,0) = 0.000000; -NODES[1018](BODY_FORCE_X,0) = 0.000000; -NODES[1018](BODY_FORCE_Y,0) = -9.810000; -NODES[1018](BODY_FORCE_Z,0) = 0.000000; -NODES[1019](BODY_FORCE_X,0) = 0.000000; -NODES[1019](BODY_FORCE_Y,0) = -9.810000; -NODES[1019](BODY_FORCE_Z,0) = 0.000000; -NODES[1020](BODY_FORCE_X,0) = 0.000000; -NODES[1020](BODY_FORCE_Y,0) = -9.810000; -NODES[1020](BODY_FORCE_Z,0) = 0.000000; -NODES[1021](BODY_FORCE_X,0) = 0.000000; -NODES[1021](BODY_FORCE_Y,0) = -9.810000; -NODES[1021](BODY_FORCE_Z,0) = 0.000000; -NODES[1022](BODY_FORCE_X,0) = 0.000000; -NODES[1022](BODY_FORCE_Y,0) = -9.810000; -NODES[1022](BODY_FORCE_Z,0) = 0.000000; -NODES[1023](BODY_FORCE_X,0) = 0.000000; -NODES[1023](BODY_FORCE_Y,0) = -9.810000; -NODES[1023](BODY_FORCE_Z,0) = 0.000000; -NODES[1024](BODY_FORCE_X,0) = 0.000000; -NODES[1024](BODY_FORCE_Y,0) = -9.810000; -NODES[1024](BODY_FORCE_Z,0) = 0.000000; -NODES[1025](BODY_FORCE_X,0) = 0.000000; -NODES[1025](BODY_FORCE_Y,0) = -9.810000; -NODES[1025](BODY_FORCE_Z,0) = 0.000000; -NODES[1026](BODY_FORCE_X,0) = 0.000000; -NODES[1026](BODY_FORCE_Y,0) = -9.810000; -NODES[1026](BODY_FORCE_Z,0) = 0.000000; -NODES[1027](BODY_FORCE_X,0) = 0.000000; -NODES[1027](BODY_FORCE_Y,0) = -9.810000; -NODES[1027](BODY_FORCE_Z,0) = 0.000000; -NODES[1028](BODY_FORCE_X,0) = 0.000000; -NODES[1028](BODY_FORCE_Y,0) = -9.810000; -NODES[1028](BODY_FORCE_Z,0) = 0.000000; -NODES[1029](BODY_FORCE_X,0) = 0.000000; -NODES[1029](BODY_FORCE_Y,0) = -9.810000; -NODES[1029](BODY_FORCE_Z,0) = 0.000000; -NODES[1030](BODY_FORCE_X,0) = 0.000000; -NODES[1030](BODY_FORCE_Y,0) = -9.810000; -NODES[1030](BODY_FORCE_Z,0) = 0.000000; -NODES[1031](BODY_FORCE_X,0) = 0.000000; -NODES[1031](BODY_FORCE_Y,0) = -9.810000; -NODES[1031](BODY_FORCE_Z,0) = 0.000000; -NODES[1032](BODY_FORCE_X,0) = 0.000000; -NODES[1032](BODY_FORCE_Y,0) = -9.810000; -NODES[1032](BODY_FORCE_Z,0) = 0.000000; -NODES[1033](BODY_FORCE_X,0) = 0.000000; -NODES[1033](BODY_FORCE_Y,0) = -9.810000; -NODES[1033](BODY_FORCE_Z,0) = 0.000000; -NODES[1034](BODY_FORCE_X,0) = 0.000000; -NODES[1034](BODY_FORCE_Y,0) = -9.810000; -NODES[1034](BODY_FORCE_Z,0) = 0.000000; -NODES[1035](BODY_FORCE_X,0) = 0.000000; -NODES[1035](BODY_FORCE_Y,0) = -9.810000; -NODES[1035](BODY_FORCE_Z,0) = 0.000000; -NODES[1036](BODY_FORCE_X,0) = 0.000000; -NODES[1036](BODY_FORCE_Y,0) = -9.810000; -NODES[1036](BODY_FORCE_Z,0) = 0.000000; -NODES[1037](BODY_FORCE_X,0) = 0.000000; -NODES[1037](BODY_FORCE_Y,0) = -9.810000; -NODES[1037](BODY_FORCE_Z,0) = 0.000000; -NODES[1038](BODY_FORCE_X,0) = 0.000000; -NODES[1038](BODY_FORCE_Y,0) = -9.810000; -NODES[1038](BODY_FORCE_Z,0) = 0.000000; -NODES[1039](BODY_FORCE_X,0) = 0.000000; -NODES[1039](BODY_FORCE_Y,0) = -9.810000; -NODES[1039](BODY_FORCE_Z,0) = 0.000000; -NODES[1040](BODY_FORCE_X,0) = 0.000000; -NODES[1040](BODY_FORCE_Y,0) = -9.810000; -NODES[1040](BODY_FORCE_Z,0) = 0.000000; -NODES[1041](BODY_FORCE_X,0) = 0.000000; -NODES[1041](BODY_FORCE_Y,0) = -9.810000; -NODES[1041](BODY_FORCE_Z,0) = 0.000000; -NODES[1042](BODY_FORCE_X,0) = 0.000000; -NODES[1042](BODY_FORCE_Y,0) = -9.810000; -NODES[1042](BODY_FORCE_Z,0) = 0.000000; -NODES[1043](BODY_FORCE_X,0) = 0.000000; -NODES[1043](BODY_FORCE_Y,0) = -9.810000; -NODES[1043](BODY_FORCE_Z,0) = 0.000000; -NODES[1044](BODY_FORCE_X,0) = 0.000000; -NODES[1044](BODY_FORCE_Y,0) = -9.810000; -NODES[1044](BODY_FORCE_Z,0) = 0.000000; -NODES[1045](BODY_FORCE_X,0) = 0.000000; -NODES[1045](BODY_FORCE_Y,0) = -9.810000; -NODES[1045](BODY_FORCE_Z,0) = 0.000000; -NODES[1046](BODY_FORCE_X,0) = 0.000000; -NODES[1046](BODY_FORCE_Y,0) = -9.810000; -NODES[1046](BODY_FORCE_Z,0) = 0.000000; -NODES[1047](BODY_FORCE_X,0) = 0.000000; -NODES[1047](BODY_FORCE_Y,0) = -9.810000; -NODES[1047](BODY_FORCE_Z,0) = 0.000000; -NODES[1048](BODY_FORCE_X,0) = 0.000000; -NODES[1048](BODY_FORCE_Y,0) = -9.810000; -NODES[1048](BODY_FORCE_Z,0) = 0.000000; -NODES[1049](BODY_FORCE_X,0) = 0.000000; -NODES[1049](BODY_FORCE_Y,0) = -9.810000; -NODES[1049](BODY_FORCE_Z,0) = 0.000000; -NODES[1050](BODY_FORCE_X,0) = 0.000000; -NODES[1050](BODY_FORCE_Y,0) = -9.810000; -NODES[1050](BODY_FORCE_Z,0) = 0.000000; -NODES[1051](BODY_FORCE_X,0) = 0.000000; -NODES[1051](BODY_FORCE_Y,0) = -9.810000; -NODES[1051](BODY_FORCE_Z,0) = 0.000000; -NODES[1052](BODY_FORCE_X,0) = 0.000000; -NODES[1052](BODY_FORCE_Y,0) = -9.810000; -NODES[1052](BODY_FORCE_Z,0) = 0.000000; -NODES[1053](BODY_FORCE_X,0) = 0.000000; -NODES[1053](BODY_FORCE_Y,0) = -9.810000; -NODES[1053](BODY_FORCE_Z,0) = 0.000000; -NODES[1054](BODY_FORCE_X,0) = 0.000000; -NODES[1054](BODY_FORCE_Y,0) = -9.810000; -NODES[1054](BODY_FORCE_Z,0) = 0.000000; -NODES[1055](BODY_FORCE_X,0) = 0.000000; -NODES[1055](BODY_FORCE_Y,0) = -9.810000; -NODES[1055](BODY_FORCE_Z,0) = 0.000000; -NODES[1056](BODY_FORCE_X,0) = 0.000000; -NODES[1056](BODY_FORCE_Y,0) = -9.810000; -NODES[1056](BODY_FORCE_Z,0) = 0.000000; -NODES[1057](BODY_FORCE_X,0) = 0.000000; -NODES[1057](BODY_FORCE_Y,0) = -9.810000; -NODES[1057](BODY_FORCE_Z,0) = 0.000000; -NODES[1058](BODY_FORCE_X,0) = 0.000000; -NODES[1058](BODY_FORCE_Y,0) = -9.810000; -NODES[1058](BODY_FORCE_Z,0) = 0.000000; -NODES[1059](BODY_FORCE_X,0) = 0.000000; -NODES[1059](BODY_FORCE_Y,0) = -9.810000; -NODES[1059](BODY_FORCE_Z,0) = 0.000000; -NODES[1060](BODY_FORCE_X,0) = 0.000000; -NODES[1060](BODY_FORCE_Y,0) = -9.810000; -NODES[1060](BODY_FORCE_Z,0) = 0.000000; -NODES[1061](BODY_FORCE_X,0) = 0.000000; -NODES[1061](BODY_FORCE_Y,0) = -9.810000; -NODES[1061](BODY_FORCE_Z,0) = 0.000000; -NODES[1062](BODY_FORCE_X,0) = 0.000000; -NODES[1062](BODY_FORCE_Y,0) = -9.810000; -NODES[1062](BODY_FORCE_Z,0) = 0.000000; -NODES[1063](BODY_FORCE_X,0) = 0.000000; -NODES[1063](BODY_FORCE_Y,0) = -9.810000; -NODES[1063](BODY_FORCE_Z,0) = 0.000000; -NODES[1064](BODY_FORCE_X,0) = 0.000000; -NODES[1064](BODY_FORCE_Y,0) = -9.810000; -NODES[1064](BODY_FORCE_Z,0) = 0.000000; -NODES[1065](BODY_FORCE_X,0) = 0.000000; -NODES[1065](BODY_FORCE_Y,0) = -9.810000; -NODES[1065](BODY_FORCE_Z,0) = 0.000000; -NODES[1066](BODY_FORCE_X,0) = 0.000000; -NODES[1066](BODY_FORCE_Y,0) = -9.810000; -NODES[1066](BODY_FORCE_Z,0) = 0.000000; -NODES[1067](BODY_FORCE_X,0) = 0.000000; -NODES[1067](BODY_FORCE_Y,0) = -9.810000; -NODES[1067](BODY_FORCE_Z,0) = 0.000000; -NODES[1068](BODY_FORCE_X,0) = 0.000000; -NODES[1068](BODY_FORCE_Y,0) = -9.810000; -NODES[1068](BODY_FORCE_Z,0) = 0.000000; -NODES[1069](BODY_FORCE_X,0) = 0.000000; -NODES[1069](BODY_FORCE_Y,0) = -9.810000; -NODES[1069](BODY_FORCE_Z,0) = 0.000000; -NODES[1070](BODY_FORCE_X,0) = 0.000000; -NODES[1070](BODY_FORCE_Y,0) = -9.810000; -NODES[1070](BODY_FORCE_Z,0) = 0.000000; -NODES[1071](BODY_FORCE_X,0) = 0.000000; -NODES[1071](BODY_FORCE_Y,0) = -9.810000; -NODES[1071](BODY_FORCE_Z,0) = 0.000000; -NODES[1072](BODY_FORCE_X,0) = 0.000000; -NODES[1072](BODY_FORCE_Y,0) = -9.810000; -NODES[1072](BODY_FORCE_Z,0) = 0.000000; -NODES[1073](BODY_FORCE_X,0) = 0.000000; -NODES[1073](BODY_FORCE_Y,0) = -9.810000; -NODES[1073](BODY_FORCE_Z,0) = 0.000000; -NODES[1074](BODY_FORCE_X,0) = 0.000000; -NODES[1074](BODY_FORCE_Y,0) = -9.810000; -NODES[1074](BODY_FORCE_Z,0) = 0.000000; -NODES[1075](BODY_FORCE_X,0) = 0.000000; -NODES[1075](BODY_FORCE_Y,0) = -9.810000; -NODES[1075](BODY_FORCE_Z,0) = 0.000000; -NODES[1076](BODY_FORCE_X,0) = 0.000000; -NODES[1076](BODY_FORCE_Y,0) = -9.810000; -NODES[1076](BODY_FORCE_Z,0) = 0.000000; -NODES[1077](BODY_FORCE_X,0) = 0.000000; -NODES[1077](BODY_FORCE_Y,0) = -9.810000; -NODES[1077](BODY_FORCE_Z,0) = 0.000000; -NODES[1078](BODY_FORCE_X,0) = 0.000000; -NODES[1078](BODY_FORCE_Y,0) = -9.810000; -NODES[1078](BODY_FORCE_Z,0) = 0.000000; -NODES[1079](BODY_FORCE_X,0) = 0.000000; -NODES[1079](BODY_FORCE_Y,0) = -9.810000; -NODES[1079](BODY_FORCE_Z,0) = 0.000000; -NODES[1081](BODY_FORCE_X,0) = 0.000000; -NODES[1081](BODY_FORCE_Y,0) = -9.810000; -NODES[1081](BODY_FORCE_Z,0) = 0.000000; -NODES[1082](BODY_FORCE_X,0) = 0.000000; -NODES[1082](BODY_FORCE_Y,0) = -9.810000; -NODES[1082](BODY_FORCE_Z,0) = 0.000000; -NODES[1083](BODY_FORCE_X,0) = 0.000000; -NODES[1083](BODY_FORCE_Y,0) = -9.810000; -NODES[1083](BODY_FORCE_Z,0) = 0.000000; -NODES[1084](BODY_FORCE_X,0) = 0.000000; -NODES[1084](BODY_FORCE_Y,0) = -9.810000; -NODES[1084](BODY_FORCE_Z,0) = 0.000000; -NODES[1085](BODY_FORCE_X,0) = 0.000000; -NODES[1085](BODY_FORCE_Y,0) = -9.810000; -NODES[1085](BODY_FORCE_Z,0) = 0.000000; -NODES[1086](BODY_FORCE_X,0) = 0.000000; -NODES[1086](BODY_FORCE_Y,0) = -9.810000; -NODES[1086](BODY_FORCE_Z,0) = 0.000000; -NODES[1087](BODY_FORCE_X,0) = 0.000000; -NODES[1087](BODY_FORCE_Y,0) = -9.810000; -NODES[1087](BODY_FORCE_Z,0) = 0.000000; -NODES[1088](BODY_FORCE_X,0) = 0.000000; -NODES[1088](BODY_FORCE_Y,0) = -9.810000; -NODES[1088](BODY_FORCE_Z,0) = 0.000000; -NODES[1089](BODY_FORCE_X,0) = 0.000000; -NODES[1089](BODY_FORCE_Y,0) = -9.810000; -NODES[1089](BODY_FORCE_Z,0) = 0.000000; -NODES[1090](BODY_FORCE_X,0) = 0.000000; -NODES[1090](BODY_FORCE_Y,0) = -9.810000; -NODES[1090](BODY_FORCE_Z,0) = 0.000000; -NODES[1091](BODY_FORCE_X,0) = 0.000000; -NODES[1091](BODY_FORCE_Y,0) = -9.810000; -NODES[1091](BODY_FORCE_Z,0) = 0.000000; -NODES[1092](BODY_FORCE_X,0) = 0.000000; -NODES[1092](BODY_FORCE_Y,0) = -9.810000; -NODES[1092](BODY_FORCE_Z,0) = 0.000000; -NODES[1093](BODY_FORCE_X,0) = 0.000000; -NODES[1093](BODY_FORCE_Y,0) = -9.810000; -NODES[1093](BODY_FORCE_Z,0) = 0.000000; -NODES[1094](BODY_FORCE_X,0) = 0.000000; -NODES[1094](BODY_FORCE_Y,0) = -9.810000; -NODES[1094](BODY_FORCE_Z,0) = 0.000000; -NODES[1095](BODY_FORCE_X,0) = 0.000000; -NODES[1095](BODY_FORCE_Y,0) = -9.810000; -NODES[1095](BODY_FORCE_Z,0) = 0.000000; -NODES[1096](BODY_FORCE_X,0) = 0.000000; -NODES[1096](BODY_FORCE_Y,0) = -9.810000; -NODES[1096](BODY_FORCE_Z,0) = 0.000000; -NODES[1097](BODY_FORCE_X,0) = 0.000000; -NODES[1097](BODY_FORCE_Y,0) = -9.810000; -NODES[1097](BODY_FORCE_Z,0) = 0.000000; -NODES[1098](BODY_FORCE_X,0) = 0.000000; -NODES[1098](BODY_FORCE_Y,0) = -9.810000; -NODES[1098](BODY_FORCE_Z,0) = 0.000000; -NODES[1099](BODY_FORCE_X,0) = 0.000000; -NODES[1099](BODY_FORCE_Y,0) = -9.810000; -NODES[1099](BODY_FORCE_Z,0) = 0.000000; -NODES[1100](BODY_FORCE_X,0) = 0.000000; -NODES[1100](BODY_FORCE_Y,0) = -9.810000; -NODES[1100](BODY_FORCE_Z,0) = 0.000000; -NODES[1101](BODY_FORCE_X,0) = 0.000000; -NODES[1101](BODY_FORCE_Y,0) = -9.810000; -NODES[1101](BODY_FORCE_Z,0) = 0.000000; -NODES[1102](BODY_FORCE_X,0) = 0.000000; -NODES[1102](BODY_FORCE_Y,0) = -9.810000; -NODES[1102](BODY_FORCE_Z,0) = 0.000000; -NODES[1103](BODY_FORCE_X,0) = 0.000000; -NODES[1103](BODY_FORCE_Y,0) = -9.810000; -NODES[1103](BODY_FORCE_Z,0) = 0.000000; -NODES[1104](BODY_FORCE_X,0) = 0.000000; -NODES[1104](BODY_FORCE_Y,0) = -9.810000; -NODES[1104](BODY_FORCE_Z,0) = 0.000000; -NODES[1105](BODY_FORCE_X,0) = 0.000000; -NODES[1105](BODY_FORCE_Y,0) = -9.810000; -NODES[1105](BODY_FORCE_Z,0) = 0.000000; -NODES[1106](BODY_FORCE_X,0) = 0.000000; -NODES[1106](BODY_FORCE_Y,0) = -9.810000; -NODES[1106](BODY_FORCE_Z,0) = 0.000000; -NODES[1107](BODY_FORCE_X,0) = 0.000000; -NODES[1107](BODY_FORCE_Y,0) = -9.810000; -NODES[1107](BODY_FORCE_Z,0) = 0.000000; -NODES[1108](BODY_FORCE_X,0) = 0.000000; -NODES[1108](BODY_FORCE_Y,0) = -9.810000; -NODES[1108](BODY_FORCE_Z,0) = 0.000000; -NODES[1109](BODY_FORCE_X,0) = 0.000000; -NODES[1109](BODY_FORCE_Y,0) = -9.810000; -NODES[1109](BODY_FORCE_Z,0) = 0.000000; -NODES[1110](BODY_FORCE_X,0) = 0.000000; -NODES[1110](BODY_FORCE_Y,0) = -9.810000; -NODES[1110](BODY_FORCE_Z,0) = 0.000000; -NODES[1111](BODY_FORCE_X,0) = 0.000000; -NODES[1111](BODY_FORCE_Y,0) = -9.810000; -NODES[1111](BODY_FORCE_Z,0) = 0.000000; -NODES[1112](BODY_FORCE_X,0) = 0.000000; -NODES[1112](BODY_FORCE_Y,0) = -9.810000; -NODES[1112](BODY_FORCE_Z,0) = 0.000000; -NODES[1113](BODY_FORCE_X,0) = 0.000000; -NODES[1113](BODY_FORCE_Y,0) = -9.810000; -NODES[1113](BODY_FORCE_Z,0) = 0.000000; -NODES[1114](BODY_FORCE_X,0) = 0.000000; -NODES[1114](BODY_FORCE_Y,0) = -9.810000; -NODES[1114](BODY_FORCE_Z,0) = 0.000000; -NODES[1115](BODY_FORCE_X,0) = 0.000000; -NODES[1115](BODY_FORCE_Y,0) = -9.810000; -NODES[1115](BODY_FORCE_Z,0) = 0.000000; -NODES[1116](BODY_FORCE_X,0) = 0.000000; -NODES[1116](BODY_FORCE_Y,0) = -9.810000; -NODES[1116](BODY_FORCE_Z,0) = 0.000000; -NODES[1117](BODY_FORCE_X,0) = 0.000000; -NODES[1117](BODY_FORCE_Y,0) = -9.810000; -NODES[1117](BODY_FORCE_Z,0) = 0.000000; -NODES[1118](BODY_FORCE_X,0) = 0.000000; -NODES[1118](BODY_FORCE_Y,0) = -9.810000; -NODES[1118](BODY_FORCE_Z,0) = 0.000000; -NODES[1119](BODY_FORCE_X,0) = 0.000000; -NODES[1119](BODY_FORCE_Y,0) = -9.810000; -NODES[1119](BODY_FORCE_Z,0) = 0.000000; -NODES[1120](BODY_FORCE_X,0) = 0.000000; -NODES[1120](BODY_FORCE_Y,0) = -9.810000; -NODES[1120](BODY_FORCE_Z,0) = 0.000000; -NODES[1121](BODY_FORCE_X,0) = 0.000000; -NODES[1121](BODY_FORCE_Y,0) = -9.810000; -NODES[1121](BODY_FORCE_Z,0) = 0.000000; -NODES[1122](BODY_FORCE_X,0) = 0.000000; -NODES[1122](BODY_FORCE_Y,0) = -9.810000; -NODES[1122](BODY_FORCE_Z,0) = 0.000000; -NODES[1123](BODY_FORCE_X,0) = 0.000000; -NODES[1123](BODY_FORCE_Y,0) = -9.810000; -NODES[1123](BODY_FORCE_Z,0) = 0.000000; -NODES[1124](BODY_FORCE_X,0) = 0.000000; -NODES[1124](BODY_FORCE_Y,0) = -9.810000; -NODES[1124](BODY_FORCE_Z,0) = 0.000000; -NODES[1125](BODY_FORCE_X,0) = 0.000000; -NODES[1125](BODY_FORCE_Y,0) = -9.810000; -NODES[1125](BODY_FORCE_Z,0) = 0.000000; -NODES[1126](BODY_FORCE_X,0) = 0.000000; -NODES[1126](BODY_FORCE_Y,0) = -9.810000; -NODES[1126](BODY_FORCE_Z,0) = 0.000000; -NODES[1127](BODY_FORCE_X,0) = 0.000000; -NODES[1127](BODY_FORCE_Y,0) = -9.810000; -NODES[1127](BODY_FORCE_Z,0) = 0.000000; -NODES[1128](BODY_FORCE_X,0) = 0.000000; -NODES[1128](BODY_FORCE_Y,0) = -9.810000; -NODES[1128](BODY_FORCE_Z,0) = 0.000000; -NODES[1129](BODY_FORCE_X,0) = 0.000000; -NODES[1129](BODY_FORCE_Y,0) = -9.810000; -NODES[1129](BODY_FORCE_Z,0) = 0.000000; -NODES[1130](BODY_FORCE_X,0) = 0.000000; -NODES[1130](BODY_FORCE_Y,0) = -9.810000; -NODES[1130](BODY_FORCE_Z,0) = 0.000000; -NODES[1131](BODY_FORCE_X,0) = 0.000000; -NODES[1131](BODY_FORCE_Y,0) = -9.810000; -NODES[1131](BODY_FORCE_Z,0) = 0.000000; -NODES[1132](BODY_FORCE_X,0) = 0.000000; -NODES[1132](BODY_FORCE_Y,0) = -9.810000; -NODES[1132](BODY_FORCE_Z,0) = 0.000000; -NODES[1133](BODY_FORCE_X,0) = 0.000000; -NODES[1133](BODY_FORCE_Y,0) = -9.810000; -NODES[1133](BODY_FORCE_Z,0) = 0.000000; -NODES[1134](BODY_FORCE_X,0) = 0.000000; -NODES[1134](BODY_FORCE_Y,0) = -9.810000; -NODES[1134](BODY_FORCE_Z,0) = 0.000000; -NODES[1135](BODY_FORCE_X,0) = 0.000000; -NODES[1135](BODY_FORCE_Y,0) = -9.810000; -NODES[1135](BODY_FORCE_Z,0) = 0.000000; -NODES[1136](BODY_FORCE_X,0) = 0.000000; -NODES[1136](BODY_FORCE_Y,0) = -9.810000; -NODES[1136](BODY_FORCE_Z,0) = 0.000000; -NODES[1137](BODY_FORCE_X,0) = 0.000000; -NODES[1137](BODY_FORCE_Y,0) = -9.810000; -NODES[1137](BODY_FORCE_Z,0) = 0.000000; -NODES[1138](BODY_FORCE_X,0) = 0.000000; -NODES[1138](BODY_FORCE_Y,0) = -9.810000; -NODES[1138](BODY_FORCE_Z,0) = 0.000000; -NODES[1139](BODY_FORCE_X,0) = 0.000000; -NODES[1139](BODY_FORCE_Y,0) = -9.810000; -NODES[1139](BODY_FORCE_Z,0) = 0.000000; -NODES[1141](BODY_FORCE_X,0) = 0.000000; -NODES[1141](BODY_FORCE_Y,0) = -9.810000; -NODES[1141](BODY_FORCE_Z,0) = 0.000000; -NODES[1142](BODY_FORCE_X,0) = 0.000000; -NODES[1142](BODY_FORCE_Y,0) = -9.810000; -NODES[1142](BODY_FORCE_Z,0) = 0.000000; -NODES[1143](BODY_FORCE_X,0) = 0.000000; -NODES[1143](BODY_FORCE_Y,0) = -9.810000; -NODES[1143](BODY_FORCE_Z,0) = 0.000000; -NODES[1144](BODY_FORCE_X,0) = 0.000000; -NODES[1144](BODY_FORCE_Y,0) = -9.810000; -NODES[1144](BODY_FORCE_Z,0) = 0.000000; -NODES[1145](BODY_FORCE_X,0) = 0.000000; -NODES[1145](BODY_FORCE_Y,0) = -9.810000; -NODES[1145](BODY_FORCE_Z,0) = 0.000000; -NODES[1146](BODY_FORCE_X,0) = 0.000000; -NODES[1146](BODY_FORCE_Y,0) = -9.810000; -NODES[1146](BODY_FORCE_Z,0) = 0.000000; -NODES[1147](BODY_FORCE_X,0) = 0.000000; -NODES[1147](BODY_FORCE_Y,0) = -9.810000; -NODES[1147](BODY_FORCE_Z,0) = 0.000000; -NODES[1148](BODY_FORCE_X,0) = 0.000000; -NODES[1148](BODY_FORCE_Y,0) = -9.810000; -NODES[1148](BODY_FORCE_Z,0) = 0.000000; -NODES[1149](BODY_FORCE_X,0) = 0.000000; -NODES[1149](BODY_FORCE_Y,0) = -9.810000; -NODES[1149](BODY_FORCE_Z,0) = 0.000000; -NODES[1150](BODY_FORCE_X,0) = 0.000000; -NODES[1150](BODY_FORCE_Y,0) = -9.810000; -NODES[1150](BODY_FORCE_Z,0) = 0.000000; -NODES[1151](BODY_FORCE_X,0) = 0.000000; -NODES[1151](BODY_FORCE_Y,0) = -9.810000; -NODES[1151](BODY_FORCE_Z,0) = 0.000000; -NODES[1152](BODY_FORCE_X,0) = 0.000000; -NODES[1152](BODY_FORCE_Y,0) = -9.810000; -NODES[1152](BODY_FORCE_Z,0) = 0.000000; -NODES[1153](BODY_FORCE_X,0) = 0.000000; -NODES[1153](BODY_FORCE_Y,0) = -9.810000; -NODES[1153](BODY_FORCE_Z,0) = 0.000000; -NODES[1154](BODY_FORCE_X,0) = 0.000000; -NODES[1154](BODY_FORCE_Y,0) = -9.810000; -NODES[1154](BODY_FORCE_Z,0) = 0.000000; -NODES[1155](BODY_FORCE_X,0) = 0.000000; -NODES[1155](BODY_FORCE_Y,0) = -9.810000; -NODES[1155](BODY_FORCE_Z,0) = 0.000000; -NODES[1156](BODY_FORCE_X,0) = 0.000000; -NODES[1156](BODY_FORCE_Y,0) = -9.810000; -NODES[1156](BODY_FORCE_Z,0) = 0.000000; -NODES[1157](BODY_FORCE_X,0) = 0.000000; -NODES[1157](BODY_FORCE_Y,0) = -9.810000; -NODES[1157](BODY_FORCE_Z,0) = 0.000000; -NODES[1158](BODY_FORCE_X,0) = 0.000000; -NODES[1158](BODY_FORCE_Y,0) = -9.810000; -NODES[1158](BODY_FORCE_Z,0) = 0.000000; -NODES[1159](BODY_FORCE_X,0) = 0.000000; -NODES[1159](BODY_FORCE_Y,0) = -9.810000; -NODES[1159](BODY_FORCE_Z,0) = 0.000000; -NODES[1160](BODY_FORCE_X,0) = 0.000000; -NODES[1160](BODY_FORCE_Y,0) = -9.810000; -NODES[1160](BODY_FORCE_Z,0) = 0.000000; -NODES[1161](BODY_FORCE_X,0) = 0.000000; -NODES[1161](BODY_FORCE_Y,0) = -9.810000; -NODES[1161](BODY_FORCE_Z,0) = 0.000000; -NODES[1162](BODY_FORCE_X,0) = 0.000000; -NODES[1162](BODY_FORCE_Y,0) = -9.810000; -NODES[1162](BODY_FORCE_Z,0) = 0.000000; -NODES[1163](BODY_FORCE_X,0) = 0.000000; -NODES[1163](BODY_FORCE_Y,0) = -9.810000; -NODES[1163](BODY_FORCE_Z,0) = 0.000000; -NODES[1164](BODY_FORCE_X,0) = 0.000000; -NODES[1164](BODY_FORCE_Y,0) = -9.810000; -NODES[1164](BODY_FORCE_Z,0) = 0.000000; -NODES[1165](BODY_FORCE_X,0) = 0.000000; -NODES[1165](BODY_FORCE_Y,0) = -9.810000; -NODES[1165](BODY_FORCE_Z,0) = 0.000000; -NODES[1166](BODY_FORCE_X,0) = 0.000000; -NODES[1166](BODY_FORCE_Y,0) = -9.810000; -NODES[1166](BODY_FORCE_Z,0) = 0.000000; -NODES[1167](BODY_FORCE_X,0) = 0.000000; -NODES[1167](BODY_FORCE_Y,0) = -9.810000; -NODES[1167](BODY_FORCE_Z,0) = 0.000000; -NODES[1168](BODY_FORCE_X,0) = 0.000000; -NODES[1168](BODY_FORCE_Y,0) = -9.810000; -NODES[1168](BODY_FORCE_Z,0) = 0.000000; -NODES[1169](BODY_FORCE_X,0) = 0.000000; -NODES[1169](BODY_FORCE_Y,0) = -9.810000; -NODES[1169](BODY_FORCE_Z,0) = 0.000000; -NODES[1170](BODY_FORCE_X,0) = 0.000000; -NODES[1170](BODY_FORCE_Y,0) = -9.810000; -NODES[1170](BODY_FORCE_Z,0) = 0.000000; -NODES[1171](BODY_FORCE_X,0) = 0.000000; -NODES[1171](BODY_FORCE_Y,0) = -9.810000; -NODES[1171](BODY_FORCE_Z,0) = 0.000000; -NODES[1172](BODY_FORCE_X,0) = 0.000000; -NODES[1172](BODY_FORCE_Y,0) = -9.810000; -NODES[1172](BODY_FORCE_Z,0) = 0.000000; -NODES[1173](BODY_FORCE_X,0) = 0.000000; -NODES[1173](BODY_FORCE_Y,0) = -9.810000; -NODES[1173](BODY_FORCE_Z,0) = 0.000000; -NODES[1174](BODY_FORCE_X,0) = 0.000000; -NODES[1174](BODY_FORCE_Y,0) = -9.810000; -NODES[1174](BODY_FORCE_Z,0) = 0.000000; -NODES[1175](BODY_FORCE_X,0) = 0.000000; -NODES[1175](BODY_FORCE_Y,0) = -9.810000; -NODES[1175](BODY_FORCE_Z,0) = 0.000000; -NODES[1176](BODY_FORCE_X,0) = 0.000000; -NODES[1176](BODY_FORCE_Y,0) = -9.810000; -NODES[1176](BODY_FORCE_Z,0) = 0.000000; -NODES[1177](BODY_FORCE_X,0) = 0.000000; -NODES[1177](BODY_FORCE_Y,0) = -9.810000; -NODES[1177](BODY_FORCE_Z,0) = 0.000000; -NODES[1178](BODY_FORCE_X,0) = 0.000000; -NODES[1178](BODY_FORCE_Y,0) = -9.810000; -NODES[1178](BODY_FORCE_Z,0) = 0.000000; -NODES[1179](BODY_FORCE_X,0) = 0.000000; -NODES[1179](BODY_FORCE_Y,0) = -9.810000; -NODES[1179](BODY_FORCE_Z,0) = 0.000000; -NODES[1180](BODY_FORCE_X,0) = 0.000000; -NODES[1180](BODY_FORCE_Y,0) = -9.810000; -NODES[1180](BODY_FORCE_Z,0) = 0.000000; -NODES[1181](BODY_FORCE_X,0) = 0.000000; -NODES[1181](BODY_FORCE_Y,0) = -9.810000; -NODES[1181](BODY_FORCE_Z,0) = 0.000000; -NODES[1182](BODY_FORCE_X,0) = 0.000000; -NODES[1182](BODY_FORCE_Y,0) = -9.810000; -NODES[1182](BODY_FORCE_Z,0) = 0.000000; -NODES[1183](BODY_FORCE_X,0) = 0.000000; -NODES[1183](BODY_FORCE_Y,0) = -9.810000; -NODES[1183](BODY_FORCE_Z,0) = 0.000000; -NODES[1184](BODY_FORCE_X,0) = 0.000000; -NODES[1184](BODY_FORCE_Y,0) = -9.810000; -NODES[1184](BODY_FORCE_Z,0) = 0.000000; -NODES[1185](BODY_FORCE_X,0) = 0.000000; -NODES[1185](BODY_FORCE_Y,0) = -9.810000; -NODES[1185](BODY_FORCE_Z,0) = 0.000000; -NODES[1186](BODY_FORCE_X,0) = 0.000000; -NODES[1186](BODY_FORCE_Y,0) = -9.810000; -NODES[1186](BODY_FORCE_Z,0) = 0.000000; -NODES[1187](BODY_FORCE_X,0) = 0.000000; -NODES[1187](BODY_FORCE_Y,0) = -9.810000; -NODES[1187](BODY_FORCE_Z,0) = 0.000000; -NODES[1188](BODY_FORCE_X,0) = 0.000000; -NODES[1188](BODY_FORCE_Y,0) = -9.810000; -NODES[1188](BODY_FORCE_Z,0) = 0.000000; -NODES[1189](BODY_FORCE_X,0) = 0.000000; -NODES[1189](BODY_FORCE_Y,0) = -9.810000; -NODES[1189](BODY_FORCE_Z,0) = 0.000000; -NODES[1190](BODY_FORCE_X,0) = 0.000000; -NODES[1190](BODY_FORCE_Y,0) = -9.810000; -NODES[1190](BODY_FORCE_Z,0) = 0.000000; -NODES[1191](BODY_FORCE_X,0) = 0.000000; -NODES[1191](BODY_FORCE_Y,0) = -9.810000; -NODES[1191](BODY_FORCE_Z,0) = 0.000000; -NODES[1192](BODY_FORCE_X,0) = 0.000000; -NODES[1192](BODY_FORCE_Y,0) = -9.810000; -NODES[1192](BODY_FORCE_Z,0) = 0.000000; -NODES[1193](BODY_FORCE_X,0) = 0.000000; -NODES[1193](BODY_FORCE_Y,0) = -9.810000; -NODES[1193](BODY_FORCE_Z,0) = 0.000000; -NODES[1194](BODY_FORCE_X,0) = 0.000000; -NODES[1194](BODY_FORCE_Y,0) = -9.810000; -NODES[1194](BODY_FORCE_Z,0) = 0.000000; -NODES[1195](BODY_FORCE_X,0) = 0.000000; -NODES[1195](BODY_FORCE_Y,0) = -9.810000; -NODES[1195](BODY_FORCE_Z,0) = 0.000000; -NODES[1196](BODY_FORCE_X,0) = 0.000000; -NODES[1196](BODY_FORCE_Y,0) = -9.810000; -NODES[1196](BODY_FORCE_Z,0) = 0.000000; -NODES[1197](BODY_FORCE_X,0) = 0.000000; -NODES[1197](BODY_FORCE_Y,0) = -9.810000; -NODES[1197](BODY_FORCE_Z,0) = 0.000000; -NODES[1198](BODY_FORCE_X,0) = 0.000000; -NODES[1198](BODY_FORCE_Y,0) = -9.810000; -NODES[1198](BODY_FORCE_Z,0) = 0.000000; -NODES[1199](BODY_FORCE_X,0) = 0.000000; -NODES[1199](BODY_FORCE_Y,0) = -9.810000; -NODES[1199](BODY_FORCE_Z,0) = 0.000000; -NODES[1201](BODY_FORCE_X,0) = 0.000000; -NODES[1201](BODY_FORCE_Y,0) = -9.810000; -NODES[1201](BODY_FORCE_Z,0) = 0.000000; -NODES[1202](BODY_FORCE_X,0) = 0.000000; -NODES[1202](BODY_FORCE_Y,0) = -9.810000; -NODES[1202](BODY_FORCE_Z,0) = 0.000000; -NODES[1203](BODY_FORCE_X,0) = 0.000000; -NODES[1203](BODY_FORCE_Y,0) = -9.810000; -NODES[1203](BODY_FORCE_Z,0) = 0.000000; -NODES[1204](BODY_FORCE_X,0) = 0.000000; -NODES[1204](BODY_FORCE_Y,0) = -9.810000; -NODES[1204](BODY_FORCE_Z,0) = 0.000000; -NODES[1205](BODY_FORCE_X,0) = 0.000000; -NODES[1205](BODY_FORCE_Y,0) = -9.810000; -NODES[1205](BODY_FORCE_Z,0) = 0.000000; -NODES[1206](BODY_FORCE_X,0) = 0.000000; -NODES[1206](BODY_FORCE_Y,0) = -9.810000; -NODES[1206](BODY_FORCE_Z,0) = 0.000000; -NODES[1207](BODY_FORCE_X,0) = 0.000000; -NODES[1207](BODY_FORCE_Y,0) = -9.810000; -NODES[1207](BODY_FORCE_Z,0) = 0.000000; -NODES[1208](BODY_FORCE_X,0) = 0.000000; -NODES[1208](BODY_FORCE_Y,0) = -9.810000; -NODES[1208](BODY_FORCE_Z,0) = 0.000000; -NODES[1209](BODY_FORCE_X,0) = 0.000000; -NODES[1209](BODY_FORCE_Y,0) = -9.810000; -NODES[1209](BODY_FORCE_Z,0) = 0.000000; -NODES[1210](BODY_FORCE_X,0) = 0.000000; -NODES[1210](BODY_FORCE_Y,0) = -9.810000; -NODES[1210](BODY_FORCE_Z,0) = 0.000000; -NODES[1211](BODY_FORCE_X,0) = 0.000000; -NODES[1211](BODY_FORCE_Y,0) = -9.810000; -NODES[1211](BODY_FORCE_Z,0) = 0.000000; -NODES[1212](BODY_FORCE_X,0) = 0.000000; -NODES[1212](BODY_FORCE_Y,0) = -9.810000; -NODES[1212](BODY_FORCE_Z,0) = 0.000000; -NODES[1213](BODY_FORCE_X,0) = 0.000000; -NODES[1213](BODY_FORCE_Y,0) = -9.810000; -NODES[1213](BODY_FORCE_Z,0) = 0.000000; -NODES[1214](BODY_FORCE_X,0) = 0.000000; -NODES[1214](BODY_FORCE_Y,0) = -9.810000; -NODES[1214](BODY_FORCE_Z,0) = 0.000000; -NODES[1215](BODY_FORCE_X,0) = 0.000000; -NODES[1215](BODY_FORCE_Y,0) = -9.810000; -NODES[1215](BODY_FORCE_Z,0) = 0.000000; -NODES[1216](BODY_FORCE_X,0) = 0.000000; -NODES[1216](BODY_FORCE_Y,0) = -9.810000; -NODES[1216](BODY_FORCE_Z,0) = 0.000000; -NODES[1217](BODY_FORCE_X,0) = 0.000000; -NODES[1217](BODY_FORCE_Y,0) = -9.810000; -NODES[1217](BODY_FORCE_Z,0) = 0.000000; -NODES[1218](BODY_FORCE_X,0) = 0.000000; -NODES[1218](BODY_FORCE_Y,0) = -9.810000; -NODES[1218](BODY_FORCE_Z,0) = 0.000000; -NODES[1219](BODY_FORCE_X,0) = 0.000000; -NODES[1219](BODY_FORCE_Y,0) = -9.810000; -NODES[1219](BODY_FORCE_Z,0) = 0.000000; -NODES[1220](BODY_FORCE_X,0) = 0.000000; -NODES[1220](BODY_FORCE_Y,0) = -9.810000; -NODES[1220](BODY_FORCE_Z,0) = 0.000000; -NODES[1221](BODY_FORCE_X,0) = 0.000000; -NODES[1221](BODY_FORCE_Y,0) = -9.810000; -NODES[1221](BODY_FORCE_Z,0) = 0.000000; -NODES[1222](BODY_FORCE_X,0) = 0.000000; -NODES[1222](BODY_FORCE_Y,0) = -9.810000; -NODES[1222](BODY_FORCE_Z,0) = 0.000000; -NODES[1223](BODY_FORCE_X,0) = 0.000000; -NODES[1223](BODY_FORCE_Y,0) = -9.810000; -NODES[1223](BODY_FORCE_Z,0) = 0.000000; -NODES[1224](BODY_FORCE_X,0) = 0.000000; -NODES[1224](BODY_FORCE_Y,0) = -9.810000; -NODES[1224](BODY_FORCE_Z,0) = 0.000000; -NODES[1225](BODY_FORCE_X,0) = 0.000000; -NODES[1225](BODY_FORCE_Y,0) = -9.810000; -NODES[1225](BODY_FORCE_Z,0) = 0.000000; -NODES[1226](BODY_FORCE_X,0) = 0.000000; -NODES[1226](BODY_FORCE_Y,0) = -9.810000; -NODES[1226](BODY_FORCE_Z,0) = 0.000000; -NODES[1227](BODY_FORCE_X,0) = 0.000000; -NODES[1227](BODY_FORCE_Y,0) = -9.810000; -NODES[1227](BODY_FORCE_Z,0) = 0.000000; -NODES[1228](BODY_FORCE_X,0) = 0.000000; -NODES[1228](BODY_FORCE_Y,0) = -9.810000; -NODES[1228](BODY_FORCE_Z,0) = 0.000000; -NODES[1229](BODY_FORCE_X,0) = 0.000000; -NODES[1229](BODY_FORCE_Y,0) = -9.810000; -NODES[1229](BODY_FORCE_Z,0) = 0.000000; -NODES[1230](BODY_FORCE_X,0) = 0.000000; -NODES[1230](BODY_FORCE_Y,0) = -9.810000; -NODES[1230](BODY_FORCE_Z,0) = 0.000000; -NODES[1231](BODY_FORCE_X,0) = 0.000000; -NODES[1231](BODY_FORCE_Y,0) = -9.810000; -NODES[1231](BODY_FORCE_Z,0) = 0.000000; -NODES[1232](BODY_FORCE_X,0) = 0.000000; -NODES[1232](BODY_FORCE_Y,0) = -9.810000; -NODES[1232](BODY_FORCE_Z,0) = 0.000000; -NODES[1233](BODY_FORCE_X,0) = 0.000000; -NODES[1233](BODY_FORCE_Y,0) = -9.810000; -NODES[1233](BODY_FORCE_Z,0) = 0.000000; -NODES[1234](BODY_FORCE_X,0) = 0.000000; -NODES[1234](BODY_FORCE_Y,0) = -9.810000; -NODES[1234](BODY_FORCE_Z,0) = 0.000000; -NODES[1235](BODY_FORCE_X,0) = 0.000000; -NODES[1235](BODY_FORCE_Y,0) = -9.810000; -NODES[1235](BODY_FORCE_Z,0) = 0.000000; -NODES[1236](BODY_FORCE_X,0) = 0.000000; -NODES[1236](BODY_FORCE_Y,0) = -9.810000; -NODES[1236](BODY_FORCE_Z,0) = 0.000000; -NODES[1237](BODY_FORCE_X,0) = 0.000000; -NODES[1237](BODY_FORCE_Y,0) = -9.810000; -NODES[1237](BODY_FORCE_Z,0) = 0.000000; -NODES[1238](BODY_FORCE_X,0) = 0.000000; -NODES[1238](BODY_FORCE_Y,0) = -9.810000; -NODES[1238](BODY_FORCE_Z,0) = 0.000000; -NODES[1239](BODY_FORCE_X,0) = 0.000000; -NODES[1239](BODY_FORCE_Y,0) = -9.810000; -NODES[1239](BODY_FORCE_Z,0) = 0.000000; -NODES[1240](BODY_FORCE_X,0) = 0.000000; -NODES[1240](BODY_FORCE_Y,0) = -9.810000; -NODES[1240](BODY_FORCE_Z,0) = 0.000000; -NODES[1241](BODY_FORCE_X,0) = 0.000000; -NODES[1241](BODY_FORCE_Y,0) = -9.810000; -NODES[1241](BODY_FORCE_Z,0) = 0.000000; -NODES[1242](BODY_FORCE_X,0) = 0.000000; -NODES[1242](BODY_FORCE_Y,0) = -9.810000; -NODES[1242](BODY_FORCE_Z,0) = 0.000000; -NODES[1243](BODY_FORCE_X,0) = 0.000000; -NODES[1243](BODY_FORCE_Y,0) = -9.810000; -NODES[1243](BODY_FORCE_Z,0) = 0.000000; -NODES[1244](BODY_FORCE_X,0) = 0.000000; -NODES[1244](BODY_FORCE_Y,0) = -9.810000; -NODES[1244](BODY_FORCE_Z,0) = 0.000000; -NODES[1245](BODY_FORCE_X,0) = 0.000000; -NODES[1245](BODY_FORCE_Y,0) = -9.810000; -NODES[1245](BODY_FORCE_Z,0) = 0.000000; -NODES[1246](BODY_FORCE_X,0) = 0.000000; -NODES[1246](BODY_FORCE_Y,0) = -9.810000; -NODES[1246](BODY_FORCE_Z,0) = 0.000000; -NODES[1247](BODY_FORCE_X,0) = 0.000000; -NODES[1247](BODY_FORCE_Y,0) = -9.810000; -NODES[1247](BODY_FORCE_Z,0) = 0.000000; -NODES[1248](BODY_FORCE_X,0) = 0.000000; -NODES[1248](BODY_FORCE_Y,0) = -9.810000; -NODES[1248](BODY_FORCE_Z,0) = 0.000000; -NODES[1249](BODY_FORCE_X,0) = 0.000000; -NODES[1249](BODY_FORCE_Y,0) = -9.810000; -NODES[1249](BODY_FORCE_Z,0) = 0.000000; -NODES[1250](BODY_FORCE_X,0) = 0.000000; -NODES[1250](BODY_FORCE_Y,0) = -9.810000; -NODES[1250](BODY_FORCE_Z,0) = 0.000000; -NODES[1251](BODY_FORCE_X,0) = 0.000000; -NODES[1251](BODY_FORCE_Y,0) = -9.810000; -NODES[1251](BODY_FORCE_Z,0) = 0.000000; -NODES[1253](BODY_FORCE_X,0) = 0.000000; -NODES[1253](BODY_FORCE_Y,0) = -9.810000; -NODES[1253](BODY_FORCE_Z,0) = 0.000000; -NODES[1254](BODY_FORCE_X,0) = 0.000000; -NODES[1254](BODY_FORCE_Y,0) = -9.810000; -NODES[1254](BODY_FORCE_Z,0) = 0.000000; -NODES[1255](BODY_FORCE_X,0) = 0.000000; -NODES[1255](BODY_FORCE_Y,0) = -9.810000; -NODES[1255](BODY_FORCE_Z,0) = 0.000000; -NODES[1256](BODY_FORCE_X,0) = 0.000000; -NODES[1256](BODY_FORCE_Y,0) = -9.810000; -NODES[1256](BODY_FORCE_Z,0) = 0.000000; -NODES[1257](BODY_FORCE_X,0) = 0.000000; -NODES[1257](BODY_FORCE_Y,0) = -9.810000; -NODES[1257](BODY_FORCE_Z,0) = 0.000000; -NODES[1258](BODY_FORCE_X,0) = 0.000000; -NODES[1258](BODY_FORCE_Y,0) = -9.810000; -NODES[1258](BODY_FORCE_Z,0) = 0.000000; -NODES[1259](BODY_FORCE_X,0) = 0.000000; -NODES[1259](BODY_FORCE_Y,0) = -9.810000; -NODES[1259](BODY_FORCE_Z,0) = 0.000000; -NODES[1260](BODY_FORCE_X,0) = 0.000000; -NODES[1260](BODY_FORCE_Y,0) = -9.810000; -NODES[1260](BODY_FORCE_Z,0) = 0.000000; -NODES[1261](BODY_FORCE_X,0) = 0.000000; -NODES[1261](BODY_FORCE_Y,0) = -9.810000; -NODES[1261](BODY_FORCE_Z,0) = 0.000000; -NODES[1262](BODY_FORCE_X,0) = 0.000000; -NODES[1262](BODY_FORCE_Y,0) = -9.810000; -NODES[1262](BODY_FORCE_Z,0) = 0.000000; -NODES[1263](BODY_FORCE_X,0) = 0.000000; -NODES[1263](BODY_FORCE_Y,0) = -9.810000; -NODES[1263](BODY_FORCE_Z,0) = 0.000000; -NODES[1264](BODY_FORCE_X,0) = 0.000000; -NODES[1264](BODY_FORCE_Y,0) = -9.810000; -NODES[1264](BODY_FORCE_Z,0) = 0.000000; -NODES[1265](BODY_FORCE_X,0) = 0.000000; -NODES[1265](BODY_FORCE_Y,0) = -9.810000; -NODES[1265](BODY_FORCE_Z,0) = 0.000000; -NODES[1266](BODY_FORCE_X,0) = 0.000000; -NODES[1266](BODY_FORCE_Y,0) = -9.810000; -NODES[1266](BODY_FORCE_Z,0) = 0.000000; -NODES[1267](BODY_FORCE_X,0) = 0.000000; -NODES[1267](BODY_FORCE_Y,0) = -9.810000; -NODES[1267](BODY_FORCE_Z,0) = 0.000000; -NODES[1268](BODY_FORCE_X,0) = 0.000000; -NODES[1268](BODY_FORCE_Y,0) = -9.810000; -NODES[1268](BODY_FORCE_Z,0) = 0.000000; -NODES[1269](BODY_FORCE_X,0) = 0.000000; -NODES[1269](BODY_FORCE_Y,0) = -9.810000; -NODES[1269](BODY_FORCE_Z,0) = 0.000000; -NODES[1270](BODY_FORCE_X,0) = 0.000000; -NODES[1270](BODY_FORCE_Y,0) = -9.810000; -NODES[1270](BODY_FORCE_Z,0) = 0.000000; -NODES[1271](BODY_FORCE_X,0) = 0.000000; -NODES[1271](BODY_FORCE_Y,0) = -9.810000; -NODES[1271](BODY_FORCE_Z,0) = 0.000000; -NODES[1272](BODY_FORCE_X,0) = 0.000000; -NODES[1272](BODY_FORCE_Y,0) = -9.810000; -NODES[1272](BODY_FORCE_Z,0) = 0.000000; -NODES[1273](BODY_FORCE_X,0) = 0.000000; -NODES[1273](BODY_FORCE_Y,0) = -9.810000; -NODES[1273](BODY_FORCE_Z,0) = 0.000000; -NODES[1274](BODY_FORCE_X,0) = 0.000000; -NODES[1274](BODY_FORCE_Y,0) = -9.810000; -NODES[1274](BODY_FORCE_Z,0) = 0.000000; -NODES[1275](BODY_FORCE_X,0) = 0.000000; -NODES[1275](BODY_FORCE_Y,0) = -9.810000; -NODES[1275](BODY_FORCE_Z,0) = 0.000000; -NODES[1276](BODY_FORCE_X,0) = 0.000000; -NODES[1276](BODY_FORCE_Y,0) = -9.810000; -NODES[1276](BODY_FORCE_Z,0) = 0.000000; -NODES[1277](BODY_FORCE_X,0) = 0.000000; -NODES[1277](BODY_FORCE_Y,0) = -9.810000; -NODES[1277](BODY_FORCE_Z,0) = 0.000000; -NODES[1278](BODY_FORCE_X,0) = 0.000000; -NODES[1278](BODY_FORCE_Y,0) = -9.810000; -NODES[1278](BODY_FORCE_Z,0) = 0.000000; -NODES[1279](BODY_FORCE_X,0) = 0.000000; -NODES[1279](BODY_FORCE_Y,0) = -9.810000; -NODES[1279](BODY_FORCE_Z,0) = 0.000000; -NODES[1280](BODY_FORCE_X,0) = 0.000000; -NODES[1280](BODY_FORCE_Y,0) = -9.810000; -NODES[1280](BODY_FORCE_Z,0) = 0.000000; -NODES[1281](BODY_FORCE_X,0) = 0.000000; -NODES[1281](BODY_FORCE_Y,0) = -9.810000; -NODES[1281](BODY_FORCE_Z,0) = 0.000000; -NODES[1282](BODY_FORCE_X,0) = 0.000000; -NODES[1282](BODY_FORCE_Y,0) = -9.810000; -NODES[1282](BODY_FORCE_Z,0) = 0.000000; -NODES[1283](BODY_FORCE_X,0) = 0.000000; -NODES[1283](BODY_FORCE_Y,0) = -9.810000; -NODES[1283](BODY_FORCE_Z,0) = 0.000000; -NODES[1284](BODY_FORCE_X,0) = 0.000000; -NODES[1284](BODY_FORCE_Y,0) = -9.810000; -NODES[1284](BODY_FORCE_Z,0) = 0.000000; -NODES[1285](BODY_FORCE_X,0) = 0.000000; -NODES[1285](BODY_FORCE_Y,0) = -9.810000; -NODES[1285](BODY_FORCE_Z,0) = 0.000000; -NODES[1286](BODY_FORCE_X,0) = 0.000000; -NODES[1286](BODY_FORCE_Y,0) = -9.810000; -NODES[1286](BODY_FORCE_Z,0) = 0.000000; -NODES[1287](BODY_FORCE_X,0) = 0.000000; -NODES[1287](BODY_FORCE_Y,0) = -9.810000; -NODES[1287](BODY_FORCE_Z,0) = 0.000000; -NODES[1288](BODY_FORCE_X,0) = 0.000000; -NODES[1288](BODY_FORCE_Y,0) = -9.810000; -NODES[1288](BODY_FORCE_Z,0) = 0.000000; -NODES[1289](BODY_FORCE_X,0) = 0.000000; -NODES[1289](BODY_FORCE_Y,0) = -9.810000; -NODES[1289](BODY_FORCE_Z,0) = 0.000000; -NODES[1290](BODY_FORCE_X,0) = 0.000000; -NODES[1290](BODY_FORCE_Y,0) = -9.810000; -NODES[1290](BODY_FORCE_Z,0) = 0.000000; -NODES[1291](BODY_FORCE_X,0) = 0.000000; -NODES[1291](BODY_FORCE_Y,0) = -9.810000; -NODES[1291](BODY_FORCE_Z,0) = 0.000000; -NODES[1292](BODY_FORCE_X,0) = 0.000000; -NODES[1292](BODY_FORCE_Y,0) = -9.810000; -NODES[1292](BODY_FORCE_Z,0) = 0.000000; -NODES[1293](BODY_FORCE_X,0) = 0.000000; -NODES[1293](BODY_FORCE_Y,0) = -9.810000; -NODES[1293](BODY_FORCE_Z,0) = 0.000000; -NODES[1294](BODY_FORCE_X,0) = 0.000000; -NODES[1294](BODY_FORCE_Y,0) = -9.810000; -NODES[1294](BODY_FORCE_Z,0) = 0.000000; -NODES[1295](BODY_FORCE_X,0) = 0.000000; -NODES[1295](BODY_FORCE_Y,0) = -9.810000; -NODES[1295](BODY_FORCE_Z,0) = 0.000000; -NODES[1296](BODY_FORCE_X,0) = 0.000000; -NODES[1296](BODY_FORCE_Y,0) = -9.810000; -NODES[1296](BODY_FORCE_Z,0) = 0.000000; -NODES[1297](BODY_FORCE_X,0) = 0.000000; -NODES[1297](BODY_FORCE_Y,0) = -9.810000; -NODES[1297](BODY_FORCE_Z,0) = 0.000000; -NODES[1298](BODY_FORCE_X,0) = 0.000000; -NODES[1298](BODY_FORCE_Y,0) = -9.810000; -NODES[1298](BODY_FORCE_Z,0) = 0.000000; -NODES[1299](BODY_FORCE_X,0) = 0.000000; -NODES[1299](BODY_FORCE_Y,0) = -9.810000; -NODES[1299](BODY_FORCE_Z,0) = 0.000000; -NODES[1300](BODY_FORCE_X,0) = 0.000000; -NODES[1300](BODY_FORCE_Y,0) = -9.810000; -NODES[1300](BODY_FORCE_Z,0) = 0.000000; -NODES[1302](BODY_FORCE_X,0) = 0.000000; -NODES[1302](BODY_FORCE_Y,0) = -9.810000; -NODES[1302](BODY_FORCE_Z,0) = 0.000000; -NODES[1303](BODY_FORCE_X,0) = 0.000000; -NODES[1303](BODY_FORCE_Y,0) = -9.810000; -NODES[1303](BODY_FORCE_Z,0) = 0.000000; -NODES[1304](BODY_FORCE_X,0) = 0.000000; -NODES[1304](BODY_FORCE_Y,0) = -9.810000; -NODES[1304](BODY_FORCE_Z,0) = 0.000000; -NODES[1305](BODY_FORCE_X,0) = 0.000000; -NODES[1305](BODY_FORCE_Y,0) = -9.810000; -NODES[1305](BODY_FORCE_Z,0) = 0.000000; -NODES[1306](BODY_FORCE_X,0) = 0.000000; -NODES[1306](BODY_FORCE_Y,0) = -9.810000; -NODES[1306](BODY_FORCE_Z,0) = 0.000000; -NODES[1307](BODY_FORCE_X,0) = 0.000000; -NODES[1307](BODY_FORCE_Y,0) = -9.810000; -NODES[1307](BODY_FORCE_Z,0) = 0.000000; -NODES[1308](BODY_FORCE_X,0) = 0.000000; -NODES[1308](BODY_FORCE_Y,0) = -9.810000; -NODES[1308](BODY_FORCE_Z,0) = 0.000000; -NODES[1309](BODY_FORCE_X,0) = 0.000000; -NODES[1309](BODY_FORCE_Y,0) = -9.810000; -NODES[1309](BODY_FORCE_Z,0) = 0.000000; -NODES[1310](BODY_FORCE_X,0) = 0.000000; -NODES[1310](BODY_FORCE_Y,0) = -9.810000; -NODES[1310](BODY_FORCE_Z,0) = 0.000000; -NODES[1311](BODY_FORCE_X,0) = 0.000000; -NODES[1311](BODY_FORCE_Y,0) = -9.810000; -NODES[1311](BODY_FORCE_Z,0) = 0.000000; -NODES[1312](BODY_FORCE_X,0) = 0.000000; -NODES[1312](BODY_FORCE_Y,0) = -9.810000; -NODES[1312](BODY_FORCE_Z,0) = 0.000000; -NODES[1313](BODY_FORCE_X,0) = 0.000000; -NODES[1313](BODY_FORCE_Y,0) = -9.810000; -NODES[1313](BODY_FORCE_Z,0) = 0.000000; -NODES[1314](BODY_FORCE_X,0) = 0.000000; -NODES[1314](BODY_FORCE_Y,0) = -9.810000; -NODES[1314](BODY_FORCE_Z,0) = 0.000000; -NODES[1315](BODY_FORCE_X,0) = 0.000000; -NODES[1315](BODY_FORCE_Y,0) = -9.810000; -NODES[1315](BODY_FORCE_Z,0) = 0.000000; -NODES[1316](BODY_FORCE_X,0) = 0.000000; -NODES[1316](BODY_FORCE_Y,0) = -9.810000; -NODES[1316](BODY_FORCE_Z,0) = 0.000000; -NODES[1317](BODY_FORCE_X,0) = 0.000000; -NODES[1317](BODY_FORCE_Y,0) = -9.810000; -NODES[1317](BODY_FORCE_Z,0) = 0.000000; -NODES[1318](BODY_FORCE_X,0) = 0.000000; -NODES[1318](BODY_FORCE_Y,0) = -9.810000; -NODES[1318](BODY_FORCE_Z,0) = 0.000000; -NODES[1319](BODY_FORCE_X,0) = 0.000000; -NODES[1319](BODY_FORCE_Y,0) = -9.810000; -NODES[1319](BODY_FORCE_Z,0) = 0.000000; -NODES[1320](BODY_FORCE_X,0) = 0.000000; -NODES[1320](BODY_FORCE_Y,0) = -9.810000; -NODES[1320](BODY_FORCE_Z,0) = 0.000000; -NODES[1321](BODY_FORCE_X,0) = 0.000000; -NODES[1321](BODY_FORCE_Y,0) = -9.810000; -NODES[1321](BODY_FORCE_Z,0) = 0.000000; -NODES[1322](BODY_FORCE_X,0) = 0.000000; -NODES[1322](BODY_FORCE_Y,0) = -9.810000; -NODES[1322](BODY_FORCE_Z,0) = 0.000000; -NODES[1323](BODY_FORCE_X,0) = 0.000000; -NODES[1323](BODY_FORCE_Y,0) = -9.810000; -NODES[1323](BODY_FORCE_Z,0) = 0.000000; -NODES[1324](BODY_FORCE_X,0) = 0.000000; -NODES[1324](BODY_FORCE_Y,0) = -9.810000; -NODES[1324](BODY_FORCE_Z,0) = 0.000000; -NODES[1325](BODY_FORCE_X,0) = 0.000000; -NODES[1325](BODY_FORCE_Y,0) = -9.810000; -NODES[1325](BODY_FORCE_Z,0) = 0.000000; -NODES[1326](BODY_FORCE_X,0) = 0.000000; -NODES[1326](BODY_FORCE_Y,0) = -9.810000; -NODES[1326](BODY_FORCE_Z,0) = 0.000000; -NODES[1327](BODY_FORCE_X,0) = 0.000000; -NODES[1327](BODY_FORCE_Y,0) = -9.810000; -NODES[1327](BODY_FORCE_Z,0) = 0.000000; -NODES[1328](BODY_FORCE_X,0) = 0.000000; -NODES[1328](BODY_FORCE_Y,0) = -9.810000; -NODES[1328](BODY_FORCE_Z,0) = 0.000000; -NODES[1329](BODY_FORCE_X,0) = 0.000000; -NODES[1329](BODY_FORCE_Y,0) = -9.810000; -NODES[1329](BODY_FORCE_Z,0) = 0.000000; -NODES[1330](BODY_FORCE_X,0) = 0.000000; -NODES[1330](BODY_FORCE_Y,0) = -9.810000; -NODES[1330](BODY_FORCE_Z,0) = 0.000000; -NODES[1331](BODY_FORCE_X,0) = 0.000000; -NODES[1331](BODY_FORCE_Y,0) = -9.810000; -NODES[1331](BODY_FORCE_Z,0) = 0.000000; -NODES[1332](BODY_FORCE_X,0) = 0.000000; -NODES[1332](BODY_FORCE_Y,0) = -9.810000; -NODES[1332](BODY_FORCE_Z,0) = 0.000000; -NODES[1333](BODY_FORCE_X,0) = 0.000000; -NODES[1333](BODY_FORCE_Y,0) = -9.810000; -NODES[1333](BODY_FORCE_Z,0) = 0.000000; -NODES[1334](BODY_FORCE_X,0) = 0.000000; -NODES[1334](BODY_FORCE_Y,0) = -9.810000; -NODES[1334](BODY_FORCE_Z,0) = 0.000000; -NODES[1335](BODY_FORCE_X,0) = 0.000000; -NODES[1335](BODY_FORCE_Y,0) = -9.810000; -NODES[1335](BODY_FORCE_Z,0) = 0.000000; -NODES[1336](BODY_FORCE_X,0) = 0.000000; -NODES[1336](BODY_FORCE_Y,0) = -9.810000; -NODES[1336](BODY_FORCE_Z,0) = 0.000000; -NODES[1337](BODY_FORCE_X,0) = 0.000000; -NODES[1337](BODY_FORCE_Y,0) = -9.810000; -NODES[1337](BODY_FORCE_Z,0) = 0.000000; -NODES[1338](BODY_FORCE_X,0) = 0.000000; -NODES[1338](BODY_FORCE_Y,0) = -9.810000; -NODES[1338](BODY_FORCE_Z,0) = 0.000000; -NODES[1339](BODY_FORCE_X,0) = 0.000000; -NODES[1339](BODY_FORCE_Y,0) = -9.810000; -NODES[1339](BODY_FORCE_Z,0) = 0.000000; -NODES[1340](BODY_FORCE_X,0) = 0.000000; -NODES[1340](BODY_FORCE_Y,0) = -9.810000; -NODES[1340](BODY_FORCE_Z,0) = 0.000000; -NODES[1341](BODY_FORCE_X,0) = 0.000000; -NODES[1341](BODY_FORCE_Y,0) = -9.810000; -NODES[1341](BODY_FORCE_Z,0) = 0.000000; -NODES[1342](BODY_FORCE_X,0) = 0.000000; -NODES[1342](BODY_FORCE_Y,0) = -9.810000; -NODES[1342](BODY_FORCE_Z,0) = 0.000000; -NODES[1343](BODY_FORCE_X,0) = 0.000000; -NODES[1343](BODY_FORCE_Y,0) = -9.810000; -NODES[1343](BODY_FORCE_Z,0) = 0.000000; -NODES[1344](BODY_FORCE_X,0) = 0.000000; -NODES[1344](BODY_FORCE_Y,0) = -9.810000; -NODES[1344](BODY_FORCE_Z,0) = 0.000000; -NODES[1345](BODY_FORCE_X,0) = 0.000000; -NODES[1345](BODY_FORCE_Y,0) = -9.810000; -NODES[1345](BODY_FORCE_Z,0) = 0.000000; -NODES[1346](BODY_FORCE_X,0) = 0.000000; -NODES[1346](BODY_FORCE_Y,0) = -9.810000; -NODES[1346](BODY_FORCE_Z,0) = 0.000000; -NODES[1347](BODY_FORCE_X,0) = 0.000000; -NODES[1347](BODY_FORCE_Y,0) = -9.810000; -NODES[1347](BODY_FORCE_Z,0) = 0.000000; -NODES[1348](BODY_FORCE_X,0) = 0.000000; -NODES[1348](BODY_FORCE_Y,0) = -9.810000; -NODES[1348](BODY_FORCE_Z,0) = 0.000000; -NODES[1350](BODY_FORCE_X,0) = 0.000000; -NODES[1350](BODY_FORCE_Y,0) = -9.810000; -NODES[1350](BODY_FORCE_Z,0) = 0.000000; -NODES[1351](BODY_FORCE_X,0) = 0.000000; -NODES[1351](BODY_FORCE_Y,0) = -9.810000; -NODES[1351](BODY_FORCE_Z,0) = 0.000000; -NODES[1352](BODY_FORCE_X,0) = 0.000000; -NODES[1352](BODY_FORCE_Y,0) = -9.810000; -NODES[1352](BODY_FORCE_Z,0) = 0.000000; -NODES[1353](BODY_FORCE_X,0) = 0.000000; -NODES[1353](BODY_FORCE_Y,0) = -9.810000; -NODES[1353](BODY_FORCE_Z,0) = 0.000000; -NODES[1354](BODY_FORCE_X,0) = 0.000000; -NODES[1354](BODY_FORCE_Y,0) = -9.810000; -NODES[1354](BODY_FORCE_Z,0) = 0.000000; -NODES[1355](BODY_FORCE_X,0) = 0.000000; -NODES[1355](BODY_FORCE_Y,0) = -9.810000; -NODES[1355](BODY_FORCE_Z,0) = 0.000000; -NODES[1356](BODY_FORCE_X,0) = 0.000000; -NODES[1356](BODY_FORCE_Y,0) = -9.810000; -NODES[1356](BODY_FORCE_Z,0) = 0.000000; -NODES[1357](BODY_FORCE_X,0) = 0.000000; -NODES[1357](BODY_FORCE_Y,0) = -9.810000; -NODES[1357](BODY_FORCE_Z,0) = 0.000000; -NODES[1358](BODY_FORCE_X,0) = 0.000000; -NODES[1358](BODY_FORCE_Y,0) = -9.810000; -NODES[1358](BODY_FORCE_Z,0) = 0.000000; -NODES[1359](BODY_FORCE_X,0) = 0.000000; -NODES[1359](BODY_FORCE_Y,0) = -9.810000; -NODES[1359](BODY_FORCE_Z,0) = 0.000000; -NODES[1360](BODY_FORCE_X,0) = 0.000000; -NODES[1360](BODY_FORCE_Y,0) = -9.810000; -NODES[1360](BODY_FORCE_Z,0) = 0.000000; -NODES[1361](BODY_FORCE_X,0) = 0.000000; -NODES[1361](BODY_FORCE_Y,0) = -9.810000; -NODES[1361](BODY_FORCE_Z,0) = 0.000000; -NODES[1362](BODY_FORCE_X,0) = 0.000000; -NODES[1362](BODY_FORCE_Y,0) = -9.810000; -NODES[1362](BODY_FORCE_Z,0) = 0.000000; -NODES[1363](BODY_FORCE_X,0) = 0.000000; -NODES[1363](BODY_FORCE_Y,0) = -9.810000; -NODES[1363](BODY_FORCE_Z,0) = 0.000000; -NODES[1364](BODY_FORCE_X,0) = 0.000000; -NODES[1364](BODY_FORCE_Y,0) = -9.810000; -NODES[1364](BODY_FORCE_Z,0) = 0.000000; -NODES[1365](BODY_FORCE_X,0) = 0.000000; -NODES[1365](BODY_FORCE_Y,0) = -9.810000; -NODES[1365](BODY_FORCE_Z,0) = 0.000000; -NODES[1366](BODY_FORCE_X,0) = 0.000000; -NODES[1366](BODY_FORCE_Y,0) = -9.810000; -NODES[1366](BODY_FORCE_Z,0) = 0.000000; -NODES[1367](BODY_FORCE_X,0) = 0.000000; -NODES[1367](BODY_FORCE_Y,0) = -9.810000; -NODES[1367](BODY_FORCE_Z,0) = 0.000000; -NODES[1368](BODY_FORCE_X,0) = 0.000000; -NODES[1368](BODY_FORCE_Y,0) = -9.810000; -NODES[1368](BODY_FORCE_Z,0) = 0.000000; -NODES[1369](BODY_FORCE_X,0) = 0.000000; -NODES[1369](BODY_FORCE_Y,0) = -9.810000; -NODES[1369](BODY_FORCE_Z,0) = 0.000000; -NODES[1370](BODY_FORCE_X,0) = 0.000000; -NODES[1370](BODY_FORCE_Y,0) = -9.810000; -NODES[1370](BODY_FORCE_Z,0) = 0.000000; -NODES[1371](BODY_FORCE_X,0) = 0.000000; -NODES[1371](BODY_FORCE_Y,0) = -9.810000; -NODES[1371](BODY_FORCE_Z,0) = 0.000000; -NODES[1372](BODY_FORCE_X,0) = 0.000000; -NODES[1372](BODY_FORCE_Y,0) = -9.810000; -NODES[1372](BODY_FORCE_Z,0) = 0.000000; -NODES[1373](BODY_FORCE_X,0) = 0.000000; -NODES[1373](BODY_FORCE_Y,0) = -9.810000; -NODES[1373](BODY_FORCE_Z,0) = 0.000000; -NODES[1374](BODY_FORCE_X,0) = 0.000000; -NODES[1374](BODY_FORCE_Y,0) = -9.810000; -NODES[1374](BODY_FORCE_Z,0) = 0.000000; -NODES[1375](BODY_FORCE_X,0) = 0.000000; -NODES[1375](BODY_FORCE_Y,0) = -9.810000; -NODES[1375](BODY_FORCE_Z,0) = 0.000000; -NODES[1376](BODY_FORCE_X,0) = 0.000000; -NODES[1376](BODY_FORCE_Y,0) = -9.810000; -NODES[1376](BODY_FORCE_Z,0) = 0.000000; -NODES[1377](BODY_FORCE_X,0) = 0.000000; -NODES[1377](BODY_FORCE_Y,0) = -9.810000; -NODES[1377](BODY_FORCE_Z,0) = 0.000000; -NODES[1378](BODY_FORCE_X,0) = 0.000000; -NODES[1378](BODY_FORCE_Y,0) = -9.810000; -NODES[1378](BODY_FORCE_Z,0) = 0.000000; -NODES[1379](BODY_FORCE_X,0) = 0.000000; -NODES[1379](BODY_FORCE_Y,0) = -9.810000; -NODES[1379](BODY_FORCE_Z,0) = 0.000000; -NODES[1380](BODY_FORCE_X,0) = 0.000000; -NODES[1380](BODY_FORCE_Y,0) = -9.810000; -NODES[1380](BODY_FORCE_Z,0) = 0.000000; -NODES[1381](BODY_FORCE_X,0) = 0.000000; -NODES[1381](BODY_FORCE_Y,0) = -9.810000; -NODES[1381](BODY_FORCE_Z,0) = 0.000000; -NODES[1382](BODY_FORCE_X,0) = 0.000000; -NODES[1382](BODY_FORCE_Y,0) = -9.810000; -NODES[1382](BODY_FORCE_Z,0) = 0.000000; -NODES[1383](BODY_FORCE_X,0) = 0.000000; -NODES[1383](BODY_FORCE_Y,0) = -9.810000; -NODES[1383](BODY_FORCE_Z,0) = 0.000000; -NODES[1384](BODY_FORCE_X,0) = 0.000000; -NODES[1384](BODY_FORCE_Y,0) = -9.810000; -NODES[1384](BODY_FORCE_Z,0) = 0.000000; -NODES[1385](BODY_FORCE_X,0) = 0.000000; -NODES[1385](BODY_FORCE_Y,0) = -9.810000; -NODES[1385](BODY_FORCE_Z,0) = 0.000000; -NODES[1386](BODY_FORCE_X,0) = 0.000000; -NODES[1386](BODY_FORCE_Y,0) = -9.810000; -NODES[1386](BODY_FORCE_Z,0) = 0.000000; -NODES[1387](BODY_FORCE_X,0) = 0.000000; -NODES[1387](BODY_FORCE_Y,0) = -9.810000; -NODES[1387](BODY_FORCE_Z,0) = 0.000000; -NODES[1388](BODY_FORCE_X,0) = 0.000000; -NODES[1388](BODY_FORCE_Y,0) = -9.810000; -NODES[1388](BODY_FORCE_Z,0) = 0.000000; -NODES[1389](BODY_FORCE_X,0) = 0.000000; -NODES[1389](BODY_FORCE_Y,0) = -9.810000; -NODES[1389](BODY_FORCE_Z,0) = 0.000000; -NODES[1390](BODY_FORCE_X,0) = 0.000000; -NODES[1390](BODY_FORCE_Y,0) = -9.810000; -NODES[1390](BODY_FORCE_Z,0) = 0.000000; -NODES[1391](BODY_FORCE_X,0) = 0.000000; -NODES[1391](BODY_FORCE_Y,0) = -9.810000; -NODES[1391](BODY_FORCE_Z,0) = 0.000000; -NODES[1392](BODY_FORCE_X,0) = 0.000000; -NODES[1392](BODY_FORCE_Y,0) = -9.810000; -NODES[1392](BODY_FORCE_Z,0) = 0.000000; -NODES[1393](BODY_FORCE_X,0) = 0.000000; -NODES[1393](BODY_FORCE_Y,0) = -9.810000; -NODES[1393](BODY_FORCE_Z,0) = 0.000000; -NODES[1394](BODY_FORCE_X,0) = 0.000000; -NODES[1394](BODY_FORCE_Y,0) = -9.810000; -NODES[1394](BODY_FORCE_Z,0) = 0.000000; -NODES[1395](BODY_FORCE_X,0) = 0.000000; -NODES[1395](BODY_FORCE_Y,0) = -9.810000; -NODES[1395](BODY_FORCE_Z,0) = 0.000000; -NODES[1397](BODY_FORCE_X,0) = 0.000000; -NODES[1397](BODY_FORCE_Y,0) = -9.810000; -NODES[1397](BODY_FORCE_Z,0) = 0.000000; -NODES[1398](BODY_FORCE_X,0) = 0.000000; -NODES[1398](BODY_FORCE_Y,0) = -9.810000; -NODES[1398](BODY_FORCE_Z,0) = 0.000000; -NODES[1399](BODY_FORCE_X,0) = 0.000000; -NODES[1399](BODY_FORCE_Y,0) = -9.810000; -NODES[1399](BODY_FORCE_Z,0) = 0.000000; -NODES[1400](BODY_FORCE_X,0) = 0.000000; -NODES[1400](BODY_FORCE_Y,0) = -9.810000; -NODES[1400](BODY_FORCE_Z,0) = 0.000000; -NODES[1401](BODY_FORCE_X,0) = 0.000000; -NODES[1401](BODY_FORCE_Y,0) = -9.810000; -NODES[1401](BODY_FORCE_Z,0) = 0.000000; -NODES[1402](BODY_FORCE_X,0) = 0.000000; -NODES[1402](BODY_FORCE_Y,0) = -9.810000; -NODES[1402](BODY_FORCE_Z,0) = 0.000000; -NODES[1403](BODY_FORCE_X,0) = 0.000000; -NODES[1403](BODY_FORCE_Y,0) = -9.810000; -NODES[1403](BODY_FORCE_Z,0) = 0.000000; -NODES[1404](BODY_FORCE_X,0) = 0.000000; -NODES[1404](BODY_FORCE_Y,0) = -9.810000; -NODES[1404](BODY_FORCE_Z,0) = 0.000000; -NODES[1405](BODY_FORCE_X,0) = 0.000000; -NODES[1405](BODY_FORCE_Y,0) = -9.810000; -NODES[1405](BODY_FORCE_Z,0) = 0.000000; -NODES[1406](BODY_FORCE_X,0) = 0.000000; -NODES[1406](BODY_FORCE_Y,0) = -9.810000; -NODES[1406](BODY_FORCE_Z,0) = 0.000000; -NODES[1407](BODY_FORCE_X,0) = 0.000000; -NODES[1407](BODY_FORCE_Y,0) = -9.810000; -NODES[1407](BODY_FORCE_Z,0) = 0.000000; -NODES[1408](BODY_FORCE_X,0) = 0.000000; -NODES[1408](BODY_FORCE_Y,0) = -9.810000; -NODES[1408](BODY_FORCE_Z,0) = 0.000000; -NODES[1409](BODY_FORCE_X,0) = 0.000000; -NODES[1409](BODY_FORCE_Y,0) = -9.810000; -NODES[1409](BODY_FORCE_Z,0) = 0.000000; -NODES[1410](BODY_FORCE_X,0) = 0.000000; -NODES[1410](BODY_FORCE_Y,0) = -9.810000; -NODES[1410](BODY_FORCE_Z,0) = 0.000000; -NODES[1411](BODY_FORCE_X,0) = 0.000000; -NODES[1411](BODY_FORCE_Y,0) = -9.810000; -NODES[1411](BODY_FORCE_Z,0) = 0.000000; -NODES[1412](BODY_FORCE_X,0) = 0.000000; -NODES[1412](BODY_FORCE_Y,0) = -9.810000; -NODES[1412](BODY_FORCE_Z,0) = 0.000000; -NODES[1413](BODY_FORCE_X,0) = 0.000000; -NODES[1413](BODY_FORCE_Y,0) = -9.810000; -NODES[1413](BODY_FORCE_Z,0) = 0.000000; -NODES[1414](BODY_FORCE_X,0) = 0.000000; -NODES[1414](BODY_FORCE_Y,0) = -9.810000; -NODES[1414](BODY_FORCE_Z,0) = 0.000000; -NODES[1415](BODY_FORCE_X,0) = 0.000000; -NODES[1415](BODY_FORCE_Y,0) = -9.810000; -NODES[1415](BODY_FORCE_Z,0) = 0.000000; -NODES[1416](BODY_FORCE_X,0) = 0.000000; -NODES[1416](BODY_FORCE_Y,0) = -9.810000; -NODES[1416](BODY_FORCE_Z,0) = 0.000000; -NODES[1417](BODY_FORCE_X,0) = 0.000000; -NODES[1417](BODY_FORCE_Y,0) = -9.810000; -NODES[1417](BODY_FORCE_Z,0) = 0.000000; -NODES[1418](BODY_FORCE_X,0) = 0.000000; -NODES[1418](BODY_FORCE_Y,0) = -9.810000; -NODES[1418](BODY_FORCE_Z,0) = 0.000000; -NODES[1419](BODY_FORCE_X,0) = 0.000000; -NODES[1419](BODY_FORCE_Y,0) = -9.810000; -NODES[1419](BODY_FORCE_Z,0) = 0.000000; -NODES[1420](BODY_FORCE_X,0) = 0.000000; -NODES[1420](BODY_FORCE_Y,0) = -9.810000; -NODES[1420](BODY_FORCE_Z,0) = 0.000000; -NODES[1421](BODY_FORCE_X,0) = 0.000000; -NODES[1421](BODY_FORCE_Y,0) = -9.810000; -NODES[1421](BODY_FORCE_Z,0) = 0.000000; -NODES[1422](BODY_FORCE_X,0) = 0.000000; -NODES[1422](BODY_FORCE_Y,0) = -9.810000; -NODES[1422](BODY_FORCE_Z,0) = 0.000000; -NODES[1423](BODY_FORCE_X,0) = 0.000000; -NODES[1423](BODY_FORCE_Y,0) = -9.810000; -NODES[1423](BODY_FORCE_Z,0) = 0.000000; -NODES[1424](BODY_FORCE_X,0) = 0.000000; -NODES[1424](BODY_FORCE_Y,0) = -9.810000; -NODES[1424](BODY_FORCE_Z,0) = 0.000000; -NODES[1425](BODY_FORCE_X,0) = 0.000000; -NODES[1425](BODY_FORCE_Y,0) = -9.810000; -NODES[1425](BODY_FORCE_Z,0) = 0.000000; -NODES[1426](BODY_FORCE_X,0) = 0.000000; -NODES[1426](BODY_FORCE_Y,0) = -9.810000; -NODES[1426](BODY_FORCE_Z,0) = 0.000000; -NODES[1427](BODY_FORCE_X,0) = 0.000000; -NODES[1427](BODY_FORCE_Y,0) = -9.810000; -NODES[1427](BODY_FORCE_Z,0) = 0.000000; -NODES[1428](BODY_FORCE_X,0) = 0.000000; -NODES[1428](BODY_FORCE_Y,0) = -9.810000; -NODES[1428](BODY_FORCE_Z,0) = 0.000000; -NODES[1429](BODY_FORCE_X,0) = 0.000000; -NODES[1429](BODY_FORCE_Y,0) = -9.810000; -NODES[1429](BODY_FORCE_Z,0) = 0.000000; -NODES[1430](BODY_FORCE_X,0) = 0.000000; -NODES[1430](BODY_FORCE_Y,0) = -9.810000; -NODES[1430](BODY_FORCE_Z,0) = 0.000000; -NODES[1431](BODY_FORCE_X,0) = 0.000000; -NODES[1431](BODY_FORCE_Y,0) = -9.810000; -NODES[1431](BODY_FORCE_Z,0) = 0.000000; -NODES[1432](BODY_FORCE_X,0) = 0.000000; -NODES[1432](BODY_FORCE_Y,0) = -9.810000; -NODES[1432](BODY_FORCE_Z,0) = 0.000000; -NODES[1433](BODY_FORCE_X,0) = 0.000000; -NODES[1433](BODY_FORCE_Y,0) = -9.810000; -NODES[1433](BODY_FORCE_Z,0) = 0.000000; -NODES[1434](BODY_FORCE_X,0) = 0.000000; -NODES[1434](BODY_FORCE_Y,0) = -9.810000; -NODES[1434](BODY_FORCE_Z,0) = 0.000000; -NODES[1435](BODY_FORCE_X,0) = 0.000000; -NODES[1435](BODY_FORCE_Y,0) = -9.810000; -NODES[1435](BODY_FORCE_Z,0) = 0.000000; -NODES[1436](BODY_FORCE_X,0) = 0.000000; -NODES[1436](BODY_FORCE_Y,0) = -9.810000; -NODES[1436](BODY_FORCE_Z,0) = 0.000000; -NODES[1437](BODY_FORCE_X,0) = 0.000000; -NODES[1437](BODY_FORCE_Y,0) = -9.810000; -NODES[1437](BODY_FORCE_Z,0) = 0.000000; -NODES[1438](BODY_FORCE_X,0) = 0.000000; -NODES[1438](BODY_FORCE_Y,0) = -9.810000; -NODES[1438](BODY_FORCE_Z,0) = 0.000000; -NODES[1439](BODY_FORCE_X,0) = 0.000000; -NODES[1439](BODY_FORCE_Y,0) = -9.810000; -NODES[1439](BODY_FORCE_Z,0) = 0.000000; -NODES[1440](BODY_FORCE_X,0) = 0.000000; -NODES[1440](BODY_FORCE_Y,0) = -9.810000; -NODES[1440](BODY_FORCE_Z,0) = 0.000000; -NODES[1442](BODY_FORCE_X,0) = 0.000000; -NODES[1442](BODY_FORCE_Y,0) = -9.810000; -NODES[1442](BODY_FORCE_Z,0) = 0.000000; -NODES[1443](BODY_FORCE_X,0) = 0.000000; -NODES[1443](BODY_FORCE_Y,0) = -9.810000; -NODES[1443](BODY_FORCE_Z,0) = 0.000000; -NODES[1444](BODY_FORCE_X,0) = 0.000000; -NODES[1444](BODY_FORCE_Y,0) = -9.810000; -NODES[1444](BODY_FORCE_Z,0) = 0.000000; -NODES[1445](BODY_FORCE_X,0) = 0.000000; -NODES[1445](BODY_FORCE_Y,0) = -9.810000; -NODES[1445](BODY_FORCE_Z,0) = 0.000000; -NODES[1446](BODY_FORCE_X,0) = 0.000000; -NODES[1446](BODY_FORCE_Y,0) = -9.810000; -NODES[1446](BODY_FORCE_Z,0) = 0.000000; -NODES[1447](BODY_FORCE_X,0) = 0.000000; -NODES[1447](BODY_FORCE_Y,0) = -9.810000; -NODES[1447](BODY_FORCE_Z,0) = 0.000000; -NODES[1448](BODY_FORCE_X,0) = 0.000000; -NODES[1448](BODY_FORCE_Y,0) = -9.810000; -NODES[1448](BODY_FORCE_Z,0) = 0.000000; -NODES[1449](BODY_FORCE_X,0) = 0.000000; -NODES[1449](BODY_FORCE_Y,0) = -9.810000; -NODES[1449](BODY_FORCE_Z,0) = 0.000000; -NODES[1450](BODY_FORCE_X,0) = 0.000000; -NODES[1450](BODY_FORCE_Y,0) = -9.810000; -NODES[1450](BODY_FORCE_Z,0) = 0.000000; -NODES[1451](BODY_FORCE_X,0) = 0.000000; -NODES[1451](BODY_FORCE_Y,0) = -9.810000; -NODES[1451](BODY_FORCE_Z,0) = 0.000000; -NODES[1452](BODY_FORCE_X,0) = 0.000000; -NODES[1452](BODY_FORCE_Y,0) = -9.810000; -NODES[1452](BODY_FORCE_Z,0) = 0.000000; -NODES[1453](BODY_FORCE_X,0) = 0.000000; -NODES[1453](BODY_FORCE_Y,0) = -9.810000; -NODES[1453](BODY_FORCE_Z,0) = 0.000000; -NODES[1454](BODY_FORCE_X,0) = 0.000000; -NODES[1454](BODY_FORCE_Y,0) = -9.810000; -NODES[1454](BODY_FORCE_Z,0) = 0.000000; -NODES[1455](BODY_FORCE_X,0) = 0.000000; -NODES[1455](BODY_FORCE_Y,0) = -9.810000; -NODES[1455](BODY_FORCE_Z,0) = 0.000000; -NODES[1456](BODY_FORCE_X,0) = 0.000000; -NODES[1456](BODY_FORCE_Y,0) = -9.810000; -NODES[1456](BODY_FORCE_Z,0) = 0.000000; -NODES[1457](BODY_FORCE_X,0) = 0.000000; -NODES[1457](BODY_FORCE_Y,0) = -9.810000; -NODES[1457](BODY_FORCE_Z,0) = 0.000000; -NODES[1458](BODY_FORCE_X,0) = 0.000000; -NODES[1458](BODY_FORCE_Y,0) = -9.810000; -NODES[1458](BODY_FORCE_Z,0) = 0.000000; -NODES[1459](BODY_FORCE_X,0) = 0.000000; -NODES[1459](BODY_FORCE_Y,0) = -9.810000; -NODES[1459](BODY_FORCE_Z,0) = 0.000000; -NODES[1460](BODY_FORCE_X,0) = 0.000000; -NODES[1460](BODY_FORCE_Y,0) = -9.810000; -NODES[1460](BODY_FORCE_Z,0) = 0.000000; -NODES[1461](BODY_FORCE_X,0) = 0.000000; -NODES[1461](BODY_FORCE_Y,0) = -9.810000; -NODES[1461](BODY_FORCE_Z,0) = 0.000000; -NODES[1462](BODY_FORCE_X,0) = 0.000000; -NODES[1462](BODY_FORCE_Y,0) = -9.810000; -NODES[1462](BODY_FORCE_Z,0) = 0.000000; -NODES[1463](BODY_FORCE_X,0) = 0.000000; -NODES[1463](BODY_FORCE_Y,0) = -9.810000; -NODES[1463](BODY_FORCE_Z,0) = 0.000000; -NODES[1464](BODY_FORCE_X,0) = 0.000000; -NODES[1464](BODY_FORCE_Y,0) = -9.810000; -NODES[1464](BODY_FORCE_Z,0) = 0.000000; -NODES[1465](BODY_FORCE_X,0) = 0.000000; -NODES[1465](BODY_FORCE_Y,0) = -9.810000; -NODES[1465](BODY_FORCE_Z,0) = 0.000000; -NODES[1466](BODY_FORCE_X,0) = 0.000000; -NODES[1466](BODY_FORCE_Y,0) = -9.810000; -NODES[1466](BODY_FORCE_Z,0) = 0.000000; -NODES[1467](BODY_FORCE_X,0) = 0.000000; -NODES[1467](BODY_FORCE_Y,0) = -9.810000; -NODES[1467](BODY_FORCE_Z,0) = 0.000000; -NODES[1468](BODY_FORCE_X,0) = 0.000000; -NODES[1468](BODY_FORCE_Y,0) = -9.810000; -NODES[1468](BODY_FORCE_Z,0) = 0.000000; -NODES[1469](BODY_FORCE_X,0) = 0.000000; -NODES[1469](BODY_FORCE_Y,0) = -9.810000; -NODES[1469](BODY_FORCE_Z,0) = 0.000000; -NODES[1470](BODY_FORCE_X,0) = 0.000000; -NODES[1470](BODY_FORCE_Y,0) = -9.810000; -NODES[1470](BODY_FORCE_Z,0) = 0.000000; -NODES[1471](BODY_FORCE_X,0) = 0.000000; -NODES[1471](BODY_FORCE_Y,0) = -9.810000; -NODES[1471](BODY_FORCE_Z,0) = 0.000000; -NODES[1472](BODY_FORCE_X,0) = 0.000000; -NODES[1472](BODY_FORCE_Y,0) = -9.810000; -NODES[1472](BODY_FORCE_Z,0) = 0.000000; -NODES[1473](BODY_FORCE_X,0) = 0.000000; -NODES[1473](BODY_FORCE_Y,0) = -9.810000; -NODES[1473](BODY_FORCE_Z,0) = 0.000000; -NODES[1474](BODY_FORCE_X,0) = 0.000000; -NODES[1474](BODY_FORCE_Y,0) = -9.810000; -NODES[1474](BODY_FORCE_Z,0) = 0.000000; -NODES[1475](BODY_FORCE_X,0) = 0.000000; -NODES[1475](BODY_FORCE_Y,0) = -9.810000; -NODES[1475](BODY_FORCE_Z,0) = 0.000000; -NODES[1476](BODY_FORCE_X,0) = 0.000000; -NODES[1476](BODY_FORCE_Y,0) = -9.810000; -NODES[1476](BODY_FORCE_Z,0) = 0.000000; -NODES[1477](BODY_FORCE_X,0) = 0.000000; -NODES[1477](BODY_FORCE_Y,0) = -9.810000; -NODES[1477](BODY_FORCE_Z,0) = 0.000000; -NODES[1478](BODY_FORCE_X,0) = 0.000000; -NODES[1478](BODY_FORCE_Y,0) = -9.810000; -NODES[1478](BODY_FORCE_Z,0) = 0.000000; -NODES[1479](BODY_FORCE_X,0) = 0.000000; -NODES[1479](BODY_FORCE_Y,0) = -9.810000; -NODES[1479](BODY_FORCE_Z,0) = 0.000000; -NODES[1480](BODY_FORCE_X,0) = 0.000000; -NODES[1480](BODY_FORCE_Y,0) = -9.810000; -NODES[1480](BODY_FORCE_Z,0) = 0.000000; -NODES[1481](BODY_FORCE_X,0) = 0.000000; -NODES[1481](BODY_FORCE_Y,0) = -9.810000; -NODES[1481](BODY_FORCE_Z,0) = 0.000000; -NODES[1482](BODY_FORCE_X,0) = 0.000000; -NODES[1482](BODY_FORCE_Y,0) = -9.810000; -NODES[1482](BODY_FORCE_Z,0) = 0.000000; -NODES[1483](BODY_FORCE_X,0) = 0.000000; -NODES[1483](BODY_FORCE_Y,0) = -9.810000; -NODES[1483](BODY_FORCE_Z,0) = 0.000000; -NODES[1484](BODY_FORCE_X,0) = 0.000000; -NODES[1484](BODY_FORCE_Y,0) = -9.810000; -NODES[1484](BODY_FORCE_Z,0) = 0.000000; -NODES[1486](BODY_FORCE_X,0) = 0.000000; -NODES[1486](BODY_FORCE_Y,0) = -9.810000; -NODES[1486](BODY_FORCE_Z,0) = 0.000000; -NODES[1487](BODY_FORCE_X,0) = 0.000000; -NODES[1487](BODY_FORCE_Y,0) = -9.810000; -NODES[1487](BODY_FORCE_Z,0) = 0.000000; -NODES[1488](BODY_FORCE_X,0) = 0.000000; -NODES[1488](BODY_FORCE_Y,0) = -9.810000; -NODES[1488](BODY_FORCE_Z,0) = 0.000000; -NODES[1489](BODY_FORCE_X,0) = 0.000000; -NODES[1489](BODY_FORCE_Y,0) = -9.810000; -NODES[1489](BODY_FORCE_Z,0) = 0.000000; -NODES[1490](BODY_FORCE_X,0) = 0.000000; -NODES[1490](BODY_FORCE_Y,0) = -9.810000; -NODES[1490](BODY_FORCE_Z,0) = 0.000000; -NODES[1491](BODY_FORCE_X,0) = 0.000000; -NODES[1491](BODY_FORCE_Y,0) = -9.810000; -NODES[1491](BODY_FORCE_Z,0) = 0.000000; -NODES[1492](BODY_FORCE_X,0) = 0.000000; -NODES[1492](BODY_FORCE_Y,0) = -9.810000; -NODES[1492](BODY_FORCE_Z,0) = 0.000000; -NODES[1493](BODY_FORCE_X,0) = 0.000000; -NODES[1493](BODY_FORCE_Y,0) = -9.810000; -NODES[1493](BODY_FORCE_Z,0) = 0.000000; -NODES[1494](BODY_FORCE_X,0) = 0.000000; -NODES[1494](BODY_FORCE_Y,0) = -9.810000; -NODES[1494](BODY_FORCE_Z,0) = 0.000000; -NODES[1495](BODY_FORCE_X,0) = 0.000000; -NODES[1495](BODY_FORCE_Y,0) = -9.810000; -NODES[1495](BODY_FORCE_Z,0) = 0.000000; -NODES[1496](BODY_FORCE_X,0) = 0.000000; -NODES[1496](BODY_FORCE_Y,0) = -9.810000; -NODES[1496](BODY_FORCE_Z,0) = 0.000000; -NODES[1497](BODY_FORCE_X,0) = 0.000000; -NODES[1497](BODY_FORCE_Y,0) = -9.810000; -NODES[1497](BODY_FORCE_Z,0) = 0.000000; -NODES[1498](BODY_FORCE_X,0) = 0.000000; -NODES[1498](BODY_FORCE_Y,0) = -9.810000; -NODES[1498](BODY_FORCE_Z,0) = 0.000000; -NODES[1499](BODY_FORCE_X,0) = 0.000000; -NODES[1499](BODY_FORCE_Y,0) = -9.810000; -NODES[1499](BODY_FORCE_Z,0) = 0.000000; -NODES[1500](BODY_FORCE_X,0) = 0.000000; -NODES[1500](BODY_FORCE_Y,0) = -9.810000; -NODES[1500](BODY_FORCE_Z,0) = 0.000000; -NODES[1501](BODY_FORCE_X,0) = 0.000000; -NODES[1501](BODY_FORCE_Y,0) = -9.810000; -NODES[1501](BODY_FORCE_Z,0) = 0.000000; -NODES[1502](BODY_FORCE_X,0) = 0.000000; -NODES[1502](BODY_FORCE_Y,0) = -9.810000; -NODES[1502](BODY_FORCE_Z,0) = 0.000000; -NODES[1503](BODY_FORCE_X,0) = 0.000000; -NODES[1503](BODY_FORCE_Y,0) = -9.810000; -NODES[1503](BODY_FORCE_Z,0) = 0.000000; -NODES[1504](BODY_FORCE_X,0) = 0.000000; -NODES[1504](BODY_FORCE_Y,0) = -9.810000; -NODES[1504](BODY_FORCE_Z,0) = 0.000000; -NODES[1505](BODY_FORCE_X,0) = 0.000000; -NODES[1505](BODY_FORCE_Y,0) = -9.810000; -NODES[1505](BODY_FORCE_Z,0) = 0.000000; -NODES[1506](BODY_FORCE_X,0) = 0.000000; -NODES[1506](BODY_FORCE_Y,0) = -9.810000; -NODES[1506](BODY_FORCE_Z,0) = 0.000000; -NODES[1507](BODY_FORCE_X,0) = 0.000000; -NODES[1507](BODY_FORCE_Y,0) = -9.810000; -NODES[1507](BODY_FORCE_Z,0) = 0.000000; -NODES[1508](BODY_FORCE_X,0) = 0.000000; -NODES[1508](BODY_FORCE_Y,0) = -9.810000; -NODES[1508](BODY_FORCE_Z,0) = 0.000000; -NODES[1509](BODY_FORCE_X,0) = 0.000000; -NODES[1509](BODY_FORCE_Y,0) = -9.810000; -NODES[1509](BODY_FORCE_Z,0) = 0.000000; -NODES[1510](BODY_FORCE_X,0) = 0.000000; -NODES[1510](BODY_FORCE_Y,0) = -9.810000; -NODES[1510](BODY_FORCE_Z,0) = 0.000000; -NODES[1511](BODY_FORCE_X,0) = 0.000000; -NODES[1511](BODY_FORCE_Y,0) = -9.810000; -NODES[1511](BODY_FORCE_Z,0) = 0.000000; -NODES[1512](BODY_FORCE_X,0) = 0.000000; -NODES[1512](BODY_FORCE_Y,0) = -9.810000; -NODES[1512](BODY_FORCE_Z,0) = 0.000000; -NODES[1513](BODY_FORCE_X,0) = 0.000000; -NODES[1513](BODY_FORCE_Y,0) = -9.810000; -NODES[1513](BODY_FORCE_Z,0) = 0.000000; -NODES[1514](BODY_FORCE_X,0) = 0.000000; -NODES[1514](BODY_FORCE_Y,0) = -9.810000; -NODES[1514](BODY_FORCE_Z,0) = 0.000000; -NODES[1515](BODY_FORCE_X,0) = 0.000000; -NODES[1515](BODY_FORCE_Y,0) = -9.810000; -NODES[1515](BODY_FORCE_Z,0) = 0.000000; -NODES[1516](BODY_FORCE_X,0) = 0.000000; -NODES[1516](BODY_FORCE_Y,0) = -9.810000; -NODES[1516](BODY_FORCE_Z,0) = 0.000000; -NODES[1517](BODY_FORCE_X,0) = 0.000000; -NODES[1517](BODY_FORCE_Y,0) = -9.810000; -NODES[1517](BODY_FORCE_Z,0) = 0.000000; -NODES[1518](BODY_FORCE_X,0) = 0.000000; -NODES[1518](BODY_FORCE_Y,0) = -9.810000; -NODES[1518](BODY_FORCE_Z,0) = 0.000000; -NODES[1519](BODY_FORCE_X,0) = 0.000000; -NODES[1519](BODY_FORCE_Y,0) = -9.810000; -NODES[1519](BODY_FORCE_Z,0) = 0.000000; -NODES[1520](BODY_FORCE_X,0) = 0.000000; -NODES[1520](BODY_FORCE_Y,0) = -9.810000; -NODES[1520](BODY_FORCE_Z,0) = 0.000000; -NODES[1521](BODY_FORCE_X,0) = 0.000000; -NODES[1521](BODY_FORCE_Y,0) = -9.810000; -NODES[1521](BODY_FORCE_Z,0) = 0.000000; -NODES[1522](BODY_FORCE_X,0) = 0.000000; -NODES[1522](BODY_FORCE_Y,0) = -9.810000; -NODES[1522](BODY_FORCE_Z,0) = 0.000000; -NODES[1523](BODY_FORCE_X,0) = 0.000000; -NODES[1523](BODY_FORCE_Y,0) = -9.810000; -NODES[1523](BODY_FORCE_Z,0) = 0.000000; -NODES[1524](BODY_FORCE_X,0) = 0.000000; -NODES[1524](BODY_FORCE_Y,0) = -9.810000; -NODES[1524](BODY_FORCE_Z,0) = 0.000000; -NODES[1525](BODY_FORCE_X,0) = 0.000000; -NODES[1525](BODY_FORCE_Y,0) = -9.810000; -NODES[1525](BODY_FORCE_Z,0) = 0.000000; -NODES[1526](BODY_FORCE_X,0) = 0.000000; -NODES[1526](BODY_FORCE_Y,0) = -9.810000; -NODES[1526](BODY_FORCE_Z,0) = 0.000000; -NODES[1528](BODY_FORCE_X,0) = 0.000000; -NODES[1528](BODY_FORCE_Y,0) = -9.810000; -NODES[1528](BODY_FORCE_Z,0) = 0.000000; -NODES[1529](BODY_FORCE_X,0) = 0.000000; -NODES[1529](BODY_FORCE_Y,0) = -9.810000; -NODES[1529](BODY_FORCE_Z,0) = 0.000000; -NODES[1530](BODY_FORCE_X,0) = 0.000000; -NODES[1530](BODY_FORCE_Y,0) = -9.810000; -NODES[1530](BODY_FORCE_Z,0) = 0.000000; -NODES[1531](BODY_FORCE_X,0) = 0.000000; -NODES[1531](BODY_FORCE_Y,0) = -9.810000; -NODES[1531](BODY_FORCE_Z,0) = 0.000000; -NODES[1532](BODY_FORCE_X,0) = 0.000000; -NODES[1532](BODY_FORCE_Y,0) = -9.810000; -NODES[1532](BODY_FORCE_Z,0) = 0.000000; -NODES[1533](BODY_FORCE_X,0) = 0.000000; -NODES[1533](BODY_FORCE_Y,0) = -9.810000; -NODES[1533](BODY_FORCE_Z,0) = 0.000000; -NODES[1534](BODY_FORCE_X,0) = 0.000000; -NODES[1534](BODY_FORCE_Y,0) = -9.810000; -NODES[1534](BODY_FORCE_Z,0) = 0.000000; -NODES[1535](BODY_FORCE_X,0) = 0.000000; -NODES[1535](BODY_FORCE_Y,0) = -9.810000; -NODES[1535](BODY_FORCE_Z,0) = 0.000000; -NODES[1536](BODY_FORCE_X,0) = 0.000000; -NODES[1536](BODY_FORCE_Y,0) = -9.810000; -NODES[1536](BODY_FORCE_Z,0) = 0.000000; -NODES[1537](BODY_FORCE_X,0) = 0.000000; -NODES[1537](BODY_FORCE_Y,0) = -9.810000; -NODES[1537](BODY_FORCE_Z,0) = 0.000000; -NODES[1538](BODY_FORCE_X,0) = 0.000000; -NODES[1538](BODY_FORCE_Y,0) = -9.810000; -NODES[1538](BODY_FORCE_Z,0) = 0.000000; -NODES[1539](BODY_FORCE_X,0) = 0.000000; -NODES[1539](BODY_FORCE_Y,0) = -9.810000; -NODES[1539](BODY_FORCE_Z,0) = 0.000000; -NODES[1540](BODY_FORCE_X,0) = 0.000000; -NODES[1540](BODY_FORCE_Y,0) = -9.810000; -NODES[1540](BODY_FORCE_Z,0) = 0.000000; -NODES[1541](BODY_FORCE_X,0) = 0.000000; -NODES[1541](BODY_FORCE_Y,0) = -9.810000; -NODES[1541](BODY_FORCE_Z,0) = 0.000000; -NODES[1542](BODY_FORCE_X,0) = 0.000000; -NODES[1542](BODY_FORCE_Y,0) = -9.810000; -NODES[1542](BODY_FORCE_Z,0) = 0.000000; -NODES[1543](BODY_FORCE_X,0) = 0.000000; -NODES[1543](BODY_FORCE_Y,0) = -9.810000; -NODES[1543](BODY_FORCE_Z,0) = 0.000000; -NODES[1544](BODY_FORCE_X,0) = 0.000000; -NODES[1544](BODY_FORCE_Y,0) = -9.810000; -NODES[1544](BODY_FORCE_Z,0) = 0.000000; -NODES[1545](BODY_FORCE_X,0) = 0.000000; -NODES[1545](BODY_FORCE_Y,0) = -9.810000; -NODES[1545](BODY_FORCE_Z,0) = 0.000000; -NODES[1546](BODY_FORCE_X,0) = 0.000000; -NODES[1546](BODY_FORCE_Y,0) = -9.810000; -NODES[1546](BODY_FORCE_Z,0) = 0.000000; -NODES[1547](BODY_FORCE_X,0) = 0.000000; -NODES[1547](BODY_FORCE_Y,0) = -9.810000; -NODES[1547](BODY_FORCE_Z,0) = 0.000000; -NODES[1548](BODY_FORCE_X,0) = 0.000000; -NODES[1548](BODY_FORCE_Y,0) = -9.810000; -NODES[1548](BODY_FORCE_Z,0) = 0.000000; -NODES[1549](BODY_FORCE_X,0) = 0.000000; -NODES[1549](BODY_FORCE_Y,0) = -9.810000; -NODES[1549](BODY_FORCE_Z,0) = 0.000000; -NODES[1550](BODY_FORCE_X,0) = 0.000000; -NODES[1550](BODY_FORCE_Y,0) = -9.810000; -NODES[1550](BODY_FORCE_Z,0) = 0.000000; -NODES[1551](BODY_FORCE_X,0) = 0.000000; -NODES[1551](BODY_FORCE_Y,0) = -9.810000; -NODES[1551](BODY_FORCE_Z,0) = 0.000000; -NODES[1552](BODY_FORCE_X,0) = 0.000000; -NODES[1552](BODY_FORCE_Y,0) = -9.810000; -NODES[1552](BODY_FORCE_Z,0) = 0.000000; -NODES[1553](BODY_FORCE_X,0) = 0.000000; -NODES[1553](BODY_FORCE_Y,0) = -9.810000; -NODES[1553](BODY_FORCE_Z,0) = 0.000000; -NODES[1554](BODY_FORCE_X,0) = 0.000000; -NODES[1554](BODY_FORCE_Y,0) = -9.810000; -NODES[1554](BODY_FORCE_Z,0) = 0.000000; -NODES[1555](BODY_FORCE_X,0) = 0.000000; -NODES[1555](BODY_FORCE_Y,0) = -9.810000; -NODES[1555](BODY_FORCE_Z,0) = 0.000000; -NODES[1556](BODY_FORCE_X,0) = 0.000000; -NODES[1556](BODY_FORCE_Y,0) = -9.810000; -NODES[1556](BODY_FORCE_Z,0) = 0.000000; -NODES[1557](BODY_FORCE_X,0) = 0.000000; -NODES[1557](BODY_FORCE_Y,0) = -9.810000; -NODES[1557](BODY_FORCE_Z,0) = 0.000000; -NODES[1558](BODY_FORCE_X,0) = 0.000000; -NODES[1558](BODY_FORCE_Y,0) = -9.810000; -NODES[1558](BODY_FORCE_Z,0) = 0.000000; -NODES[1559](BODY_FORCE_X,0) = 0.000000; -NODES[1559](BODY_FORCE_Y,0) = -9.810000; -NODES[1559](BODY_FORCE_Z,0) = 0.000000; -NODES[1560](BODY_FORCE_X,0) = 0.000000; -NODES[1560](BODY_FORCE_Y,0) = -9.810000; -NODES[1560](BODY_FORCE_Z,0) = 0.000000; -NODES[1561](BODY_FORCE_X,0) = 0.000000; -NODES[1561](BODY_FORCE_Y,0) = -9.810000; -NODES[1561](BODY_FORCE_Z,0) = 0.000000; -NODES[1562](BODY_FORCE_X,0) = 0.000000; -NODES[1562](BODY_FORCE_Y,0) = -9.810000; -NODES[1562](BODY_FORCE_Z,0) = 0.000000; -NODES[1563](BODY_FORCE_X,0) = 0.000000; -NODES[1563](BODY_FORCE_Y,0) = -9.810000; -NODES[1563](BODY_FORCE_Z,0) = 0.000000; -NODES[1564](BODY_FORCE_X,0) = 0.000000; -NODES[1564](BODY_FORCE_Y,0) = -9.810000; -NODES[1564](BODY_FORCE_Z,0) = 0.000000; -NODES[1565](BODY_FORCE_X,0) = 0.000000; -NODES[1565](BODY_FORCE_Y,0) = -9.810000; -NODES[1565](BODY_FORCE_Z,0) = 0.000000; -NODES[1566](BODY_FORCE_X,0) = 0.000000; -NODES[1566](BODY_FORCE_Y,0) = -9.810000; -NODES[1566](BODY_FORCE_Z,0) = 0.000000; -NODES[1567](BODY_FORCE_X,0) = 0.000000; -NODES[1567](BODY_FORCE_Y,0) = -9.810000; -NODES[1567](BODY_FORCE_Z,0) = 0.000000; -NODES[1568](BODY_FORCE_X,0) = 0.000000; -NODES[1568](BODY_FORCE_Y,0) = -9.810000; -NODES[1568](BODY_FORCE_Z,0) = 0.000000; -NODES[1569](BODY_FORCE_X,0) = 0.000000; -NODES[1569](BODY_FORCE_Y,0) = -9.810000; -NODES[1569](BODY_FORCE_Z,0) = 0.000000; -NODES[1570](BODY_FORCE_X,0) = 0.000000; -NODES[1570](BODY_FORCE_Y,0) = -9.810000; -NODES[1570](BODY_FORCE_Z,0) = 0.000000; -NODES[1572](BODY_FORCE_X,0) = 0.000000; -NODES[1572](BODY_FORCE_Y,0) = -9.810000; -NODES[1572](BODY_FORCE_Z,0) = 0.000000; -NODES[1573](BODY_FORCE_X,0) = 0.000000; -NODES[1573](BODY_FORCE_Y,0) = -9.810000; -NODES[1573](BODY_FORCE_Z,0) = 0.000000; -NODES[1574](BODY_FORCE_X,0) = 0.000000; -NODES[1574](BODY_FORCE_Y,0) = -9.810000; -NODES[1574](BODY_FORCE_Z,0) = 0.000000; -NODES[1575](BODY_FORCE_X,0) = 0.000000; -NODES[1575](BODY_FORCE_Y,0) = -9.810000; -NODES[1575](BODY_FORCE_Z,0) = 0.000000; -NODES[1576](BODY_FORCE_X,0) = 0.000000; -NODES[1576](BODY_FORCE_Y,0) = -9.810000; -NODES[1576](BODY_FORCE_Z,0) = 0.000000; -NODES[1577](BODY_FORCE_X,0) = 0.000000; -NODES[1577](BODY_FORCE_Y,0) = -9.810000; -NODES[1577](BODY_FORCE_Z,0) = 0.000000; -NODES[1578](BODY_FORCE_X,0) = 0.000000; -NODES[1578](BODY_FORCE_Y,0) = -9.810000; -NODES[1578](BODY_FORCE_Z,0) = 0.000000; -NODES[1579](BODY_FORCE_X,0) = 0.000000; -NODES[1579](BODY_FORCE_Y,0) = -9.810000; -NODES[1579](BODY_FORCE_Z,0) = 0.000000; -NODES[1580](BODY_FORCE_X,0) = 0.000000; -NODES[1580](BODY_FORCE_Y,0) = -9.810000; -NODES[1580](BODY_FORCE_Z,0) = 0.000000; -NODES[1581](BODY_FORCE_X,0) = 0.000000; -NODES[1581](BODY_FORCE_Y,0) = -9.810000; -NODES[1581](BODY_FORCE_Z,0) = 0.000000; -NODES[1582](BODY_FORCE_X,0) = 0.000000; -NODES[1582](BODY_FORCE_Y,0) = -9.810000; -NODES[1582](BODY_FORCE_Z,0) = 0.000000; -NODES[1583](BODY_FORCE_X,0) = 0.000000; -NODES[1583](BODY_FORCE_Y,0) = -9.810000; -NODES[1583](BODY_FORCE_Z,0) = 0.000000; -NODES[1584](BODY_FORCE_X,0) = 0.000000; -NODES[1584](BODY_FORCE_Y,0) = -9.810000; -NODES[1584](BODY_FORCE_Z,0) = 0.000000; -NODES[1585](BODY_FORCE_X,0) = 0.000000; -NODES[1585](BODY_FORCE_Y,0) = -9.810000; -NODES[1585](BODY_FORCE_Z,0) = 0.000000; -NODES[1586](BODY_FORCE_X,0) = 0.000000; -NODES[1586](BODY_FORCE_Y,0) = -9.810000; -NODES[1586](BODY_FORCE_Z,0) = 0.000000; -NODES[1587](BODY_FORCE_X,0) = 0.000000; -NODES[1587](BODY_FORCE_Y,0) = -9.810000; -NODES[1587](BODY_FORCE_Z,0) = 0.000000; -NODES[1588](BODY_FORCE_X,0) = 0.000000; -NODES[1588](BODY_FORCE_Y,0) = -9.810000; -NODES[1588](BODY_FORCE_Z,0) = 0.000000; -NODES[1589](BODY_FORCE_X,0) = 0.000000; -NODES[1589](BODY_FORCE_Y,0) = -9.810000; -NODES[1589](BODY_FORCE_Z,0) = 0.000000; -NODES[1590](BODY_FORCE_X,0) = 0.000000; -NODES[1590](BODY_FORCE_Y,0) = -9.810000; -NODES[1590](BODY_FORCE_Z,0) = 0.000000; -NODES[1591](BODY_FORCE_X,0) = 0.000000; -NODES[1591](BODY_FORCE_Y,0) = -9.810000; -NODES[1591](BODY_FORCE_Z,0) = 0.000000; -NODES[1592](BODY_FORCE_X,0) = 0.000000; -NODES[1592](BODY_FORCE_Y,0) = -9.810000; -NODES[1592](BODY_FORCE_Z,0) = 0.000000; -NODES[1593](BODY_FORCE_X,0) = 0.000000; -NODES[1593](BODY_FORCE_Y,0) = -9.810000; -NODES[1593](BODY_FORCE_Z,0) = 0.000000; -NODES[1594](BODY_FORCE_X,0) = 0.000000; -NODES[1594](BODY_FORCE_Y,0) = -9.810000; -NODES[1594](BODY_FORCE_Z,0) = 0.000000; -NODES[1595](BODY_FORCE_X,0) = 0.000000; -NODES[1595](BODY_FORCE_Y,0) = -9.810000; -NODES[1595](BODY_FORCE_Z,0) = 0.000000; -NODES[1596](BODY_FORCE_X,0) = 0.000000; -NODES[1596](BODY_FORCE_Y,0) = -9.810000; -NODES[1596](BODY_FORCE_Z,0) = 0.000000; -NODES[1597](BODY_FORCE_X,0) = 0.000000; -NODES[1597](BODY_FORCE_Y,0) = -9.810000; -NODES[1597](BODY_FORCE_Z,0) = 0.000000; -NODES[1598](BODY_FORCE_X,0) = 0.000000; -NODES[1598](BODY_FORCE_Y,0) = -9.810000; -NODES[1598](BODY_FORCE_Z,0) = 0.000000; -NODES[1599](BODY_FORCE_X,0) = 0.000000; -NODES[1599](BODY_FORCE_Y,0) = -9.810000; -NODES[1599](BODY_FORCE_Z,0) = 0.000000; -NODES[1600](BODY_FORCE_X,0) = 0.000000; -NODES[1600](BODY_FORCE_Y,0) = -9.810000; -NODES[1600](BODY_FORCE_Z,0) = 0.000000; -NODES[1601](BODY_FORCE_X,0) = 0.000000; -NODES[1601](BODY_FORCE_Y,0) = -9.810000; -NODES[1601](BODY_FORCE_Z,0) = 0.000000; -NODES[1602](BODY_FORCE_X,0) = 0.000000; -NODES[1602](BODY_FORCE_Y,0) = -9.810000; -NODES[1602](BODY_FORCE_Z,0) = 0.000000; -NODES[1603](BODY_FORCE_X,0) = 0.000000; -NODES[1603](BODY_FORCE_Y,0) = -9.810000; -NODES[1603](BODY_FORCE_Z,0) = 0.000000; -NODES[1604](BODY_FORCE_X,0) = 0.000000; -NODES[1604](BODY_FORCE_Y,0) = -9.810000; -NODES[1604](BODY_FORCE_Z,0) = 0.000000; -NODES[1605](BODY_FORCE_X,0) = 0.000000; -NODES[1605](BODY_FORCE_Y,0) = -9.810000; -NODES[1605](BODY_FORCE_Z,0) = 0.000000; -NODES[1606](BODY_FORCE_X,0) = 0.000000; -NODES[1606](BODY_FORCE_Y,0) = -9.810000; -NODES[1606](BODY_FORCE_Z,0) = 0.000000; -NODES[1607](BODY_FORCE_X,0) = 0.000000; -NODES[1607](BODY_FORCE_Y,0) = -9.810000; -NODES[1607](BODY_FORCE_Z,0) = 0.000000; -NODES[1608](BODY_FORCE_X,0) = 0.000000; -NODES[1608](BODY_FORCE_Y,0) = -9.810000; -NODES[1608](BODY_FORCE_Z,0) = 0.000000; -NODES[1609](BODY_FORCE_X,0) = 0.000000; -NODES[1609](BODY_FORCE_Y,0) = -9.810000; -NODES[1609](BODY_FORCE_Z,0) = 0.000000; -NODES[1610](BODY_FORCE_X,0) = 0.000000; -NODES[1610](BODY_FORCE_Y,0) = -9.810000; -NODES[1610](BODY_FORCE_Z,0) = 0.000000; -NODES[1612](BODY_FORCE_X,0) = 0.000000; -NODES[1612](BODY_FORCE_Y,0) = -9.810000; -NODES[1612](BODY_FORCE_Z,0) = 0.000000; -NODES[1613](BODY_FORCE_X,0) = 0.000000; -NODES[1613](BODY_FORCE_Y,0) = -9.810000; -NODES[1613](BODY_FORCE_Z,0) = 0.000000; -NODES[1614](BODY_FORCE_X,0) = 0.000000; -NODES[1614](BODY_FORCE_Y,0) = -9.810000; -NODES[1614](BODY_FORCE_Z,0) = 0.000000; -NODES[1615](BODY_FORCE_X,0) = 0.000000; -NODES[1615](BODY_FORCE_Y,0) = -9.810000; -NODES[1615](BODY_FORCE_Z,0) = 0.000000; -NODES[1616](BODY_FORCE_X,0) = 0.000000; -NODES[1616](BODY_FORCE_Y,0) = -9.810000; -NODES[1616](BODY_FORCE_Z,0) = 0.000000; -NODES[1617](BODY_FORCE_X,0) = 0.000000; -NODES[1617](BODY_FORCE_Y,0) = -9.810000; -NODES[1617](BODY_FORCE_Z,0) = 0.000000; -NODES[1618](BODY_FORCE_X,0) = 0.000000; -NODES[1618](BODY_FORCE_Y,0) = -9.810000; -NODES[1618](BODY_FORCE_Z,0) = 0.000000; -NODES[1619](BODY_FORCE_X,0) = 0.000000; -NODES[1619](BODY_FORCE_Y,0) = -9.810000; -NODES[1619](BODY_FORCE_Z,0) = 0.000000; -NODES[1620](BODY_FORCE_X,0) = 0.000000; -NODES[1620](BODY_FORCE_Y,0) = -9.810000; -NODES[1620](BODY_FORCE_Z,0) = 0.000000; -NODES[1621](BODY_FORCE_X,0) = 0.000000; -NODES[1621](BODY_FORCE_Y,0) = -9.810000; -NODES[1621](BODY_FORCE_Z,0) = 0.000000; -NODES[1622](BODY_FORCE_X,0) = 0.000000; -NODES[1622](BODY_FORCE_Y,0) = -9.810000; -NODES[1622](BODY_FORCE_Z,0) = 0.000000; -NODES[1623](BODY_FORCE_X,0) = 0.000000; -NODES[1623](BODY_FORCE_Y,0) = -9.810000; -NODES[1623](BODY_FORCE_Z,0) = 0.000000; -NODES[1624](BODY_FORCE_X,0) = 0.000000; -NODES[1624](BODY_FORCE_Y,0) = -9.810000; -NODES[1624](BODY_FORCE_Z,0) = 0.000000; -NODES[1625](BODY_FORCE_X,0) = 0.000000; -NODES[1625](BODY_FORCE_Y,0) = -9.810000; -NODES[1625](BODY_FORCE_Z,0) = 0.000000; -NODES[1626](BODY_FORCE_X,0) = 0.000000; -NODES[1626](BODY_FORCE_Y,0) = -9.810000; -NODES[1626](BODY_FORCE_Z,0) = 0.000000; -NODES[1627](BODY_FORCE_X,0) = 0.000000; -NODES[1627](BODY_FORCE_Y,0) = -9.810000; -NODES[1627](BODY_FORCE_Z,0) = 0.000000; -NODES[1628](BODY_FORCE_X,0) = 0.000000; -NODES[1628](BODY_FORCE_Y,0) = -9.810000; -NODES[1628](BODY_FORCE_Z,0) = 0.000000; -NODES[1629](BODY_FORCE_X,0) = 0.000000; -NODES[1629](BODY_FORCE_Y,0) = -9.810000; -NODES[1629](BODY_FORCE_Z,0) = 0.000000; -NODES[1630](BODY_FORCE_X,0) = 0.000000; -NODES[1630](BODY_FORCE_Y,0) = -9.810000; -NODES[1630](BODY_FORCE_Z,0) = 0.000000; -NODES[1631](BODY_FORCE_X,0) = 0.000000; -NODES[1631](BODY_FORCE_Y,0) = -9.810000; -NODES[1631](BODY_FORCE_Z,0) = 0.000000; -NODES[1632](BODY_FORCE_X,0) = 0.000000; -NODES[1632](BODY_FORCE_Y,0) = -9.810000; -NODES[1632](BODY_FORCE_Z,0) = 0.000000; -NODES[1633](BODY_FORCE_X,0) = 0.000000; -NODES[1633](BODY_FORCE_Y,0) = -9.810000; -NODES[1633](BODY_FORCE_Z,0) = 0.000000; -NODES[1634](BODY_FORCE_X,0) = 0.000000; -NODES[1634](BODY_FORCE_Y,0) = -9.810000; -NODES[1634](BODY_FORCE_Z,0) = 0.000000; -NODES[1635](BODY_FORCE_X,0) = 0.000000; -NODES[1635](BODY_FORCE_Y,0) = -9.810000; -NODES[1635](BODY_FORCE_Z,0) = 0.000000; -NODES[1636](BODY_FORCE_X,0) = 0.000000; -NODES[1636](BODY_FORCE_Y,0) = -9.810000; -NODES[1636](BODY_FORCE_Z,0) = 0.000000; -NODES[1637](BODY_FORCE_X,0) = 0.000000; -NODES[1637](BODY_FORCE_Y,0) = -9.810000; -NODES[1637](BODY_FORCE_Z,0) = 0.000000; -NODES[1638](BODY_FORCE_X,0) = 0.000000; -NODES[1638](BODY_FORCE_Y,0) = -9.810000; -NODES[1638](BODY_FORCE_Z,0) = 0.000000; -NODES[1639](BODY_FORCE_X,0) = 0.000000; -NODES[1639](BODY_FORCE_Y,0) = -9.810000; -NODES[1639](BODY_FORCE_Z,0) = 0.000000; -NODES[1640](BODY_FORCE_X,0) = 0.000000; -NODES[1640](BODY_FORCE_Y,0) = -9.810000; -NODES[1640](BODY_FORCE_Z,0) = 0.000000; -NODES[1641](BODY_FORCE_X,0) = 0.000000; -NODES[1641](BODY_FORCE_Y,0) = -9.810000; -NODES[1641](BODY_FORCE_Z,0) = 0.000000; -NODES[1642](BODY_FORCE_X,0) = 0.000000; -NODES[1642](BODY_FORCE_Y,0) = -9.810000; -NODES[1642](BODY_FORCE_Z,0) = 0.000000; -NODES[1643](BODY_FORCE_X,0) = 0.000000; -NODES[1643](BODY_FORCE_Y,0) = -9.810000; -NODES[1643](BODY_FORCE_Z,0) = 0.000000; -NODES[1644](BODY_FORCE_X,0) = 0.000000; -NODES[1644](BODY_FORCE_Y,0) = -9.810000; -NODES[1644](BODY_FORCE_Z,0) = 0.000000; -NODES[1645](BODY_FORCE_X,0) = 0.000000; -NODES[1645](BODY_FORCE_Y,0) = -9.810000; -NODES[1645](BODY_FORCE_Z,0) = 0.000000; -NODES[1646](BODY_FORCE_X,0) = 0.000000; -NODES[1646](BODY_FORCE_Y,0) = -9.810000; -NODES[1646](BODY_FORCE_Z,0) = 0.000000; -NODES[1647](BODY_FORCE_X,0) = 0.000000; -NODES[1647](BODY_FORCE_Y,0) = -9.810000; -NODES[1647](BODY_FORCE_Z,0) = 0.000000; -NODES[1648](BODY_FORCE_X,0) = 0.000000; -NODES[1648](BODY_FORCE_Y,0) = -9.810000; -NODES[1648](BODY_FORCE_Z,0) = 0.000000; -NODES[1649](BODY_FORCE_X,0) = 0.000000; -NODES[1649](BODY_FORCE_Y,0) = -9.810000; -NODES[1649](BODY_FORCE_Z,0) = 0.000000; -NODES[1650](BODY_FORCE_X,0) = 0.000000; -NODES[1650](BODY_FORCE_Y,0) = -9.810000; -NODES[1650](BODY_FORCE_Z,0) = 0.000000; -NODES[1652](BODY_FORCE_X,0) = 0.000000; -NODES[1652](BODY_FORCE_Y,0) = -9.810000; -NODES[1652](BODY_FORCE_Z,0) = 0.000000; -NODES[1653](BODY_FORCE_X,0) = 0.000000; -NODES[1653](BODY_FORCE_Y,0) = -9.810000; -NODES[1653](BODY_FORCE_Z,0) = 0.000000; -NODES[1654](BODY_FORCE_X,0) = 0.000000; -NODES[1654](BODY_FORCE_Y,0) = -9.810000; -NODES[1654](BODY_FORCE_Z,0) = 0.000000; -NODES[1655](BODY_FORCE_X,0) = 0.000000; -NODES[1655](BODY_FORCE_Y,0) = -9.810000; -NODES[1655](BODY_FORCE_Z,0) = 0.000000; -NODES[1656](BODY_FORCE_X,0) = 0.000000; -NODES[1656](BODY_FORCE_Y,0) = -9.810000; -NODES[1656](BODY_FORCE_Z,0) = 0.000000; -NODES[1657](BODY_FORCE_X,0) = 0.000000; -NODES[1657](BODY_FORCE_Y,0) = -9.810000; -NODES[1657](BODY_FORCE_Z,0) = 0.000000; -NODES[1658](BODY_FORCE_X,0) = 0.000000; -NODES[1658](BODY_FORCE_Y,0) = -9.810000; -NODES[1658](BODY_FORCE_Z,0) = 0.000000; -NODES[1659](BODY_FORCE_X,0) = 0.000000; -NODES[1659](BODY_FORCE_Y,0) = -9.810000; -NODES[1659](BODY_FORCE_Z,0) = 0.000000; -NODES[1660](BODY_FORCE_X,0) = 0.000000; -NODES[1660](BODY_FORCE_Y,0) = -9.810000; -NODES[1660](BODY_FORCE_Z,0) = 0.000000; -NODES[1661](BODY_FORCE_X,0) = 0.000000; -NODES[1661](BODY_FORCE_Y,0) = -9.810000; -NODES[1661](BODY_FORCE_Z,0) = 0.000000; -NODES[1662](BODY_FORCE_X,0) = 0.000000; -NODES[1662](BODY_FORCE_Y,0) = -9.810000; -NODES[1662](BODY_FORCE_Z,0) = 0.000000; -NODES[1663](BODY_FORCE_X,0) = 0.000000; -NODES[1663](BODY_FORCE_Y,0) = -9.810000; -NODES[1663](BODY_FORCE_Z,0) = 0.000000; -NODES[1664](BODY_FORCE_X,0) = 0.000000; -NODES[1664](BODY_FORCE_Y,0) = -9.810000; -NODES[1664](BODY_FORCE_Z,0) = 0.000000; -NODES[1665](BODY_FORCE_X,0) = 0.000000; -NODES[1665](BODY_FORCE_Y,0) = -9.810000; -NODES[1665](BODY_FORCE_Z,0) = 0.000000; -NODES[1666](BODY_FORCE_X,0) = 0.000000; -NODES[1666](BODY_FORCE_Y,0) = -9.810000; -NODES[1666](BODY_FORCE_Z,0) = 0.000000; -NODES[1667](BODY_FORCE_X,0) = 0.000000; -NODES[1667](BODY_FORCE_Y,0) = -9.810000; -NODES[1667](BODY_FORCE_Z,0) = 0.000000; -NODES[1668](BODY_FORCE_X,0) = 0.000000; -NODES[1668](BODY_FORCE_Y,0) = -9.810000; -NODES[1668](BODY_FORCE_Z,0) = 0.000000; -NODES[1669](BODY_FORCE_X,0) = 0.000000; -NODES[1669](BODY_FORCE_Y,0) = -9.810000; -NODES[1669](BODY_FORCE_Z,0) = 0.000000; -NODES[1670](BODY_FORCE_X,0) = 0.000000; -NODES[1670](BODY_FORCE_Y,0) = -9.810000; -NODES[1670](BODY_FORCE_Z,0) = 0.000000; -NODES[1671](BODY_FORCE_X,0) = 0.000000; -NODES[1671](BODY_FORCE_Y,0) = -9.810000; -NODES[1671](BODY_FORCE_Z,0) = 0.000000; -NODES[1672](BODY_FORCE_X,0) = 0.000000; -NODES[1672](BODY_FORCE_Y,0) = -9.810000; -NODES[1672](BODY_FORCE_Z,0) = 0.000000; -NODES[1673](BODY_FORCE_X,0) = 0.000000; -NODES[1673](BODY_FORCE_Y,0) = -9.810000; -NODES[1673](BODY_FORCE_Z,0) = 0.000000; -NODES[1674](BODY_FORCE_X,0) = 0.000000; -NODES[1674](BODY_FORCE_Y,0) = -9.810000; -NODES[1674](BODY_FORCE_Z,0) = 0.000000; -NODES[1675](BODY_FORCE_X,0) = 0.000000; -NODES[1675](BODY_FORCE_Y,0) = -9.810000; -NODES[1675](BODY_FORCE_Z,0) = 0.000000; -NODES[1676](BODY_FORCE_X,0) = 0.000000; -NODES[1676](BODY_FORCE_Y,0) = -9.810000; -NODES[1676](BODY_FORCE_Z,0) = 0.000000; -NODES[1677](BODY_FORCE_X,0) = 0.000000; -NODES[1677](BODY_FORCE_Y,0) = -9.810000; -NODES[1677](BODY_FORCE_Z,0) = 0.000000; -NODES[1678](BODY_FORCE_X,0) = 0.000000; -NODES[1678](BODY_FORCE_Y,0) = -9.810000; -NODES[1678](BODY_FORCE_Z,0) = 0.000000; -NODES[1679](BODY_FORCE_X,0) = 0.000000; -NODES[1679](BODY_FORCE_Y,0) = -9.810000; -NODES[1679](BODY_FORCE_Z,0) = 0.000000; -NODES[1680](BODY_FORCE_X,0) = 0.000000; -NODES[1680](BODY_FORCE_Y,0) = -9.810000; -NODES[1680](BODY_FORCE_Z,0) = 0.000000; -NODES[1681](BODY_FORCE_X,0) = 0.000000; -NODES[1681](BODY_FORCE_Y,0) = -9.810000; -NODES[1681](BODY_FORCE_Z,0) = 0.000000; -NODES[1682](BODY_FORCE_X,0) = 0.000000; -NODES[1682](BODY_FORCE_Y,0) = -9.810000; -NODES[1682](BODY_FORCE_Z,0) = 0.000000; -NODES[1683](BODY_FORCE_X,0) = 0.000000; -NODES[1683](BODY_FORCE_Y,0) = -9.810000; -NODES[1683](BODY_FORCE_Z,0) = 0.000000; -NODES[1684](BODY_FORCE_X,0) = 0.000000; -NODES[1684](BODY_FORCE_Y,0) = -9.810000; -NODES[1684](BODY_FORCE_Z,0) = 0.000000; -NODES[1685](BODY_FORCE_X,0) = 0.000000; -NODES[1685](BODY_FORCE_Y,0) = -9.810000; -NODES[1685](BODY_FORCE_Z,0) = 0.000000; -NODES[1686](BODY_FORCE_X,0) = 0.000000; -NODES[1686](BODY_FORCE_Y,0) = -9.810000; -NODES[1686](BODY_FORCE_Z,0) = 0.000000; -NODES[1687](BODY_FORCE_X,0) = 0.000000; -NODES[1687](BODY_FORCE_Y,0) = -9.810000; -NODES[1687](BODY_FORCE_Z,0) = 0.000000; -NODES[1688](BODY_FORCE_X,0) = 0.000000; -NODES[1688](BODY_FORCE_Y,0) = -9.810000; -NODES[1688](BODY_FORCE_Z,0) = 0.000000; -NODES[1689](BODY_FORCE_X,0) = 0.000000; -NODES[1689](BODY_FORCE_Y,0) = -9.810000; -NODES[1689](BODY_FORCE_Z,0) = 0.000000; -NODES[1691](BODY_FORCE_X,0) = 0.000000; -NODES[1691](BODY_FORCE_Y,0) = -9.810000; -NODES[1691](BODY_FORCE_Z,0) = 0.000000; -NODES[1692](BODY_FORCE_X,0) = 0.000000; -NODES[1692](BODY_FORCE_Y,0) = -9.810000; -NODES[1692](BODY_FORCE_Z,0) = 0.000000; -NODES[1693](BODY_FORCE_X,0) = 0.000000; -NODES[1693](BODY_FORCE_Y,0) = -9.810000; -NODES[1693](BODY_FORCE_Z,0) = 0.000000; -NODES[1694](BODY_FORCE_X,0) = 0.000000; -NODES[1694](BODY_FORCE_Y,0) = -9.810000; -NODES[1694](BODY_FORCE_Z,0) = 0.000000; -NODES[1695](BODY_FORCE_X,0) = 0.000000; -NODES[1695](BODY_FORCE_Y,0) = -9.810000; -NODES[1695](BODY_FORCE_Z,0) = 0.000000; -NODES[1696](BODY_FORCE_X,0) = 0.000000; -NODES[1696](BODY_FORCE_Y,0) = -9.810000; -NODES[1696](BODY_FORCE_Z,0) = 0.000000; -NODES[1697](BODY_FORCE_X,0) = 0.000000; -NODES[1697](BODY_FORCE_Y,0) = -9.810000; -NODES[1697](BODY_FORCE_Z,0) = 0.000000; -NODES[1698](BODY_FORCE_X,0) = 0.000000; -NODES[1698](BODY_FORCE_Y,0) = -9.810000; -NODES[1698](BODY_FORCE_Z,0) = 0.000000; -NODES[1699](BODY_FORCE_X,0) = 0.000000; -NODES[1699](BODY_FORCE_Y,0) = -9.810000; -NODES[1699](BODY_FORCE_Z,0) = 0.000000; -NODES[1700](BODY_FORCE_X,0) = 0.000000; -NODES[1700](BODY_FORCE_Y,0) = -9.810000; -NODES[1700](BODY_FORCE_Z,0) = 0.000000; -NODES[1701](BODY_FORCE_X,0) = 0.000000; -NODES[1701](BODY_FORCE_Y,0) = -9.810000; -NODES[1701](BODY_FORCE_Z,0) = 0.000000; -NODES[1702](BODY_FORCE_X,0) = 0.000000; -NODES[1702](BODY_FORCE_Y,0) = -9.810000; -NODES[1702](BODY_FORCE_Z,0) = 0.000000; -NODES[1703](BODY_FORCE_X,0) = 0.000000; -NODES[1703](BODY_FORCE_Y,0) = -9.810000; -NODES[1703](BODY_FORCE_Z,0) = 0.000000; -NODES[1704](BODY_FORCE_X,0) = 0.000000; -NODES[1704](BODY_FORCE_Y,0) = -9.810000; -NODES[1704](BODY_FORCE_Z,0) = 0.000000; -NODES[1705](BODY_FORCE_X,0) = 0.000000; -NODES[1705](BODY_FORCE_Y,0) = -9.810000; -NODES[1705](BODY_FORCE_Z,0) = 0.000000; -NODES[1706](BODY_FORCE_X,0) = 0.000000; -NODES[1706](BODY_FORCE_Y,0) = -9.810000; -NODES[1706](BODY_FORCE_Z,0) = 0.000000; -NODES[1707](BODY_FORCE_X,0) = 0.000000; -NODES[1707](BODY_FORCE_Y,0) = -9.810000; -NODES[1707](BODY_FORCE_Z,0) = 0.000000; -NODES[1708](BODY_FORCE_X,0) = 0.000000; -NODES[1708](BODY_FORCE_Y,0) = -9.810000; -NODES[1708](BODY_FORCE_Z,0) = 0.000000; -NODES[1709](BODY_FORCE_X,0) = 0.000000; -NODES[1709](BODY_FORCE_Y,0) = -9.810000; -NODES[1709](BODY_FORCE_Z,0) = 0.000000; -NODES[1710](BODY_FORCE_X,0) = 0.000000; -NODES[1710](BODY_FORCE_Y,0) = -9.810000; -NODES[1710](BODY_FORCE_Z,0) = 0.000000; -NODES[1711](BODY_FORCE_X,0) = 0.000000; -NODES[1711](BODY_FORCE_Y,0) = -9.810000; -NODES[1711](BODY_FORCE_Z,0) = 0.000000; -NODES[1712](BODY_FORCE_X,0) = 0.000000; -NODES[1712](BODY_FORCE_Y,0) = -9.810000; -NODES[1712](BODY_FORCE_Z,0) = 0.000000; -NODES[1713](BODY_FORCE_X,0) = 0.000000; -NODES[1713](BODY_FORCE_Y,0) = -9.810000; -NODES[1713](BODY_FORCE_Z,0) = 0.000000; -NODES[1714](BODY_FORCE_X,0) = 0.000000; -NODES[1714](BODY_FORCE_Y,0) = -9.810000; -NODES[1714](BODY_FORCE_Z,0) = 0.000000; -NODES[1715](BODY_FORCE_X,0) = 0.000000; -NODES[1715](BODY_FORCE_Y,0) = -9.810000; -NODES[1715](BODY_FORCE_Z,0) = 0.000000; -NODES[1716](BODY_FORCE_X,0) = 0.000000; -NODES[1716](BODY_FORCE_Y,0) = -9.810000; -NODES[1716](BODY_FORCE_Z,0) = 0.000000; -NODES[1717](BODY_FORCE_X,0) = 0.000000; -NODES[1717](BODY_FORCE_Y,0) = -9.810000; -NODES[1717](BODY_FORCE_Z,0) = 0.000000; -NODES[1718](BODY_FORCE_X,0) = 0.000000; -NODES[1718](BODY_FORCE_Y,0) = -9.810000; -NODES[1718](BODY_FORCE_Z,0) = 0.000000; -NODES[1719](BODY_FORCE_X,0) = 0.000000; -NODES[1719](BODY_FORCE_Y,0) = -9.810000; -NODES[1719](BODY_FORCE_Z,0) = 0.000000; -NODES[1720](BODY_FORCE_X,0) = 0.000000; -NODES[1720](BODY_FORCE_Y,0) = -9.810000; -NODES[1720](BODY_FORCE_Z,0) = 0.000000; -NODES[1721](BODY_FORCE_X,0) = 0.000000; -NODES[1721](BODY_FORCE_Y,0) = -9.810000; -NODES[1721](BODY_FORCE_Z,0) = 0.000000; -NODES[1722](BODY_FORCE_X,0) = 0.000000; -NODES[1722](BODY_FORCE_Y,0) = -9.810000; -NODES[1722](BODY_FORCE_Z,0) = 0.000000; -NODES[1723](BODY_FORCE_X,0) = 0.000000; -NODES[1723](BODY_FORCE_Y,0) = -9.810000; -NODES[1723](BODY_FORCE_Z,0) = 0.000000; -NODES[1724](BODY_FORCE_X,0) = 0.000000; -NODES[1724](BODY_FORCE_Y,0) = -9.810000; -NODES[1724](BODY_FORCE_Z,0) = 0.000000; -NODES[1725](BODY_FORCE_X,0) = 0.000000; -NODES[1725](BODY_FORCE_Y,0) = -9.810000; -NODES[1725](BODY_FORCE_Z,0) = 0.000000; -NODES[1726](BODY_FORCE_X,0) = 0.000000; -NODES[1726](BODY_FORCE_Y,0) = -9.810000; -NODES[1726](BODY_FORCE_Z,0) = 0.000000; -NODES[1727](BODY_FORCE_X,0) = 0.000000; -NODES[1727](BODY_FORCE_Y,0) = -9.810000; -NODES[1727](BODY_FORCE_Z,0) = 0.000000; -NODES[1728](BODY_FORCE_X,0) = 0.000000; -NODES[1728](BODY_FORCE_Y,0) = -9.810000; -NODES[1728](BODY_FORCE_Z,0) = 0.000000; -NODES[1730](BODY_FORCE_X,0) = 0.000000; -NODES[1730](BODY_FORCE_Y,0) = -9.810000; -NODES[1730](BODY_FORCE_Z,0) = 0.000000; -NODES[1731](BODY_FORCE_X,0) = 0.000000; -NODES[1731](BODY_FORCE_Y,0) = -9.810000; -NODES[1731](BODY_FORCE_Z,0) = 0.000000; -NODES[1732](BODY_FORCE_X,0) = 0.000000; -NODES[1732](BODY_FORCE_Y,0) = -9.810000; -NODES[1732](BODY_FORCE_Z,0) = 0.000000; -NODES[1733](BODY_FORCE_X,0) = 0.000000; -NODES[1733](BODY_FORCE_Y,0) = -9.810000; -NODES[1733](BODY_FORCE_Z,0) = 0.000000; -NODES[1734](BODY_FORCE_X,0) = 0.000000; -NODES[1734](BODY_FORCE_Y,0) = -9.810000; -NODES[1734](BODY_FORCE_Z,0) = 0.000000; -NODES[1735](BODY_FORCE_X,0) = 0.000000; -NODES[1735](BODY_FORCE_Y,0) = -9.810000; -NODES[1735](BODY_FORCE_Z,0) = 0.000000; -NODES[1736](BODY_FORCE_X,0) = 0.000000; -NODES[1736](BODY_FORCE_Y,0) = -9.810000; -NODES[1736](BODY_FORCE_Z,0) = 0.000000; -NODES[1737](BODY_FORCE_X,0) = 0.000000; -NODES[1737](BODY_FORCE_Y,0) = -9.810000; -NODES[1737](BODY_FORCE_Z,0) = 0.000000; -NODES[1738](BODY_FORCE_X,0) = 0.000000; -NODES[1738](BODY_FORCE_Y,0) = -9.810000; -NODES[1738](BODY_FORCE_Z,0) = 0.000000; -NODES[1739](BODY_FORCE_X,0) = 0.000000; -NODES[1739](BODY_FORCE_Y,0) = -9.810000; -NODES[1739](BODY_FORCE_Z,0) = 0.000000; -NODES[1740](BODY_FORCE_X,0) = 0.000000; -NODES[1740](BODY_FORCE_Y,0) = -9.810000; -NODES[1740](BODY_FORCE_Z,0) = 0.000000; -NODES[1741](BODY_FORCE_X,0) = 0.000000; -NODES[1741](BODY_FORCE_Y,0) = -9.810000; -NODES[1741](BODY_FORCE_Z,0) = 0.000000; -NODES[1742](BODY_FORCE_X,0) = 0.000000; -NODES[1742](BODY_FORCE_Y,0) = -9.810000; -NODES[1742](BODY_FORCE_Z,0) = 0.000000; -NODES[1743](BODY_FORCE_X,0) = 0.000000; -NODES[1743](BODY_FORCE_Y,0) = -9.810000; -NODES[1743](BODY_FORCE_Z,0) = 0.000000; -NODES[1744](BODY_FORCE_X,0) = 0.000000; -NODES[1744](BODY_FORCE_Y,0) = -9.810000; -NODES[1744](BODY_FORCE_Z,0) = 0.000000; -NODES[1745](BODY_FORCE_X,0) = 0.000000; -NODES[1745](BODY_FORCE_Y,0) = -9.810000; -NODES[1745](BODY_FORCE_Z,0) = 0.000000; -NODES[1746](BODY_FORCE_X,0) = 0.000000; -NODES[1746](BODY_FORCE_Y,0) = -9.810000; -NODES[1746](BODY_FORCE_Z,0) = 0.000000; -NODES[1747](BODY_FORCE_X,0) = 0.000000; -NODES[1747](BODY_FORCE_Y,0) = -9.810000; -NODES[1747](BODY_FORCE_Z,0) = 0.000000; -NODES[1748](BODY_FORCE_X,0) = 0.000000; -NODES[1748](BODY_FORCE_Y,0) = -9.810000; -NODES[1748](BODY_FORCE_Z,0) = 0.000000; -NODES[1749](BODY_FORCE_X,0) = 0.000000; -NODES[1749](BODY_FORCE_Y,0) = -9.810000; -NODES[1749](BODY_FORCE_Z,0) = 0.000000; -NODES[1750](BODY_FORCE_X,0) = 0.000000; -NODES[1750](BODY_FORCE_Y,0) = -9.810000; -NODES[1750](BODY_FORCE_Z,0) = 0.000000; -NODES[1751](BODY_FORCE_X,0) = 0.000000; -NODES[1751](BODY_FORCE_Y,0) = -9.810000; -NODES[1751](BODY_FORCE_Z,0) = 0.000000; -NODES[1752](BODY_FORCE_X,0) = 0.000000; -NODES[1752](BODY_FORCE_Y,0) = -9.810000; -NODES[1752](BODY_FORCE_Z,0) = 0.000000; -NODES[1753](BODY_FORCE_X,0) = 0.000000; -NODES[1753](BODY_FORCE_Y,0) = -9.810000; -NODES[1753](BODY_FORCE_Z,0) = 0.000000; -NODES[1754](BODY_FORCE_X,0) = 0.000000; -NODES[1754](BODY_FORCE_Y,0) = -9.810000; -NODES[1754](BODY_FORCE_Z,0) = 0.000000; -NODES[1755](BODY_FORCE_X,0) = 0.000000; -NODES[1755](BODY_FORCE_Y,0) = -9.810000; -NODES[1755](BODY_FORCE_Z,0) = 0.000000; -NODES[1756](BODY_FORCE_X,0) = 0.000000; -NODES[1756](BODY_FORCE_Y,0) = -9.810000; -NODES[1756](BODY_FORCE_Z,0) = 0.000000; -NODES[1757](BODY_FORCE_X,0) = 0.000000; -NODES[1757](BODY_FORCE_Y,0) = -9.810000; -NODES[1757](BODY_FORCE_Z,0) = 0.000000; -NODES[1758](BODY_FORCE_X,0) = 0.000000; -NODES[1758](BODY_FORCE_Y,0) = -9.810000; -NODES[1758](BODY_FORCE_Z,0) = 0.000000; -NODES[1759](BODY_FORCE_X,0) = 0.000000; -NODES[1759](BODY_FORCE_Y,0) = -9.810000; -NODES[1759](BODY_FORCE_Z,0) = 0.000000; -NODES[1760](BODY_FORCE_X,0) = 0.000000; -NODES[1760](BODY_FORCE_Y,0) = -9.810000; -NODES[1760](BODY_FORCE_Z,0) = 0.000000; -NODES[1761](BODY_FORCE_X,0) = 0.000000; -NODES[1761](BODY_FORCE_Y,0) = -9.810000; -NODES[1761](BODY_FORCE_Z,0) = 0.000000; -NODES[1762](BODY_FORCE_X,0) = 0.000000; -NODES[1762](BODY_FORCE_Y,0) = -9.810000; -NODES[1762](BODY_FORCE_Z,0) = 0.000000; -NODES[1763](BODY_FORCE_X,0) = 0.000000; -NODES[1763](BODY_FORCE_Y,0) = -9.810000; -NODES[1763](BODY_FORCE_Z,0) = 0.000000; -NODES[1764](BODY_FORCE_X,0) = 0.000000; -NODES[1764](BODY_FORCE_Y,0) = -9.810000; -NODES[1764](BODY_FORCE_Z,0) = 0.000000; -NODES[1765](BODY_FORCE_X,0) = 0.000000; -NODES[1765](BODY_FORCE_Y,0) = -9.810000; -NODES[1765](BODY_FORCE_Z,0) = 0.000000; -NODES[1766](BODY_FORCE_X,0) = 0.000000; -NODES[1766](BODY_FORCE_Y,0) = -9.810000; -NODES[1766](BODY_FORCE_Z,0) = 0.000000; -NODES[1768](BODY_FORCE_X,0) = 0.000000; -NODES[1768](BODY_FORCE_Y,0) = -9.810000; -NODES[1768](BODY_FORCE_Z,0) = 0.000000; -NODES[1769](BODY_FORCE_X,0) = 0.000000; -NODES[1769](BODY_FORCE_Y,0) = -9.810000; -NODES[1769](BODY_FORCE_Z,0) = 0.000000; -NODES[1770](BODY_FORCE_X,0) = 0.000000; -NODES[1770](BODY_FORCE_Y,0) = -9.810000; -NODES[1770](BODY_FORCE_Z,0) = 0.000000; -NODES[1771](BODY_FORCE_X,0) = 0.000000; -NODES[1771](BODY_FORCE_Y,0) = -9.810000; -NODES[1771](BODY_FORCE_Z,0) = 0.000000; -NODES[1772](BODY_FORCE_X,0) = 0.000000; -NODES[1772](BODY_FORCE_Y,0) = -9.810000; -NODES[1772](BODY_FORCE_Z,0) = 0.000000; -NODES[1773](BODY_FORCE_X,0) = 0.000000; -NODES[1773](BODY_FORCE_Y,0) = -9.810000; -NODES[1773](BODY_FORCE_Z,0) = 0.000000; -NODES[1774](BODY_FORCE_X,0) = 0.000000; -NODES[1774](BODY_FORCE_Y,0) = -9.810000; -NODES[1774](BODY_FORCE_Z,0) = 0.000000; -NODES[1775](BODY_FORCE_X,0) = 0.000000; -NODES[1775](BODY_FORCE_Y,0) = -9.810000; -NODES[1775](BODY_FORCE_Z,0) = 0.000000; -NODES[1776](BODY_FORCE_X,0) = 0.000000; -NODES[1776](BODY_FORCE_Y,0) = -9.810000; -NODES[1776](BODY_FORCE_Z,0) = 0.000000; -NODES[1777](BODY_FORCE_X,0) = 0.000000; -NODES[1777](BODY_FORCE_Y,0) = -9.810000; -NODES[1777](BODY_FORCE_Z,0) = 0.000000; -NODES[1778](BODY_FORCE_X,0) = 0.000000; -NODES[1778](BODY_FORCE_Y,0) = -9.810000; -NODES[1778](BODY_FORCE_Z,0) = 0.000000; -NODES[1779](BODY_FORCE_X,0) = 0.000000; -NODES[1779](BODY_FORCE_Y,0) = -9.810000; -NODES[1779](BODY_FORCE_Z,0) = 0.000000; -NODES[1780](BODY_FORCE_X,0) = 0.000000; -NODES[1780](BODY_FORCE_Y,0) = -9.810000; -NODES[1780](BODY_FORCE_Z,0) = 0.000000; -NODES[1781](BODY_FORCE_X,0) = 0.000000; -NODES[1781](BODY_FORCE_Y,0) = -9.810000; -NODES[1781](BODY_FORCE_Z,0) = 0.000000; -NODES[1782](BODY_FORCE_X,0) = 0.000000; -NODES[1782](BODY_FORCE_Y,0) = -9.810000; -NODES[1782](BODY_FORCE_Z,0) = 0.000000; -NODES[1783](BODY_FORCE_X,0) = 0.000000; -NODES[1783](BODY_FORCE_Y,0) = -9.810000; -NODES[1783](BODY_FORCE_Z,0) = 0.000000; -NODES[1784](BODY_FORCE_X,0) = 0.000000; -NODES[1784](BODY_FORCE_Y,0) = -9.810000; -NODES[1784](BODY_FORCE_Z,0) = 0.000000; -NODES[1785](BODY_FORCE_X,0) = 0.000000; -NODES[1785](BODY_FORCE_Y,0) = -9.810000; -NODES[1785](BODY_FORCE_Z,0) = 0.000000; -NODES[1786](BODY_FORCE_X,0) = 0.000000; -NODES[1786](BODY_FORCE_Y,0) = -9.810000; -NODES[1786](BODY_FORCE_Z,0) = 0.000000; -NODES[1787](BODY_FORCE_X,0) = 0.000000; -NODES[1787](BODY_FORCE_Y,0) = -9.810000; -NODES[1787](BODY_FORCE_Z,0) = 0.000000; -NODES[1788](BODY_FORCE_X,0) = 0.000000; -NODES[1788](BODY_FORCE_Y,0) = -9.810000; -NODES[1788](BODY_FORCE_Z,0) = 0.000000; -NODES[1789](BODY_FORCE_X,0) = 0.000000; -NODES[1789](BODY_FORCE_Y,0) = -9.810000; -NODES[1789](BODY_FORCE_Z,0) = 0.000000; -NODES[1790](BODY_FORCE_X,0) = 0.000000; -NODES[1790](BODY_FORCE_Y,0) = -9.810000; -NODES[1790](BODY_FORCE_Z,0) = 0.000000; -NODES[1791](BODY_FORCE_X,0) = 0.000000; -NODES[1791](BODY_FORCE_Y,0) = -9.810000; -NODES[1791](BODY_FORCE_Z,0) = 0.000000; -NODES[1792](BODY_FORCE_X,0) = 0.000000; -NODES[1792](BODY_FORCE_Y,0) = -9.810000; -NODES[1792](BODY_FORCE_Z,0) = 0.000000; -NODES[1793](BODY_FORCE_X,0) = 0.000000; -NODES[1793](BODY_FORCE_Y,0) = -9.810000; -NODES[1793](BODY_FORCE_Z,0) = 0.000000; -NODES[1794](BODY_FORCE_X,0) = 0.000000; -NODES[1794](BODY_FORCE_Y,0) = -9.810000; -NODES[1794](BODY_FORCE_Z,0) = 0.000000; -NODES[1795](BODY_FORCE_X,0) = 0.000000; -NODES[1795](BODY_FORCE_Y,0) = -9.810000; -NODES[1795](BODY_FORCE_Z,0) = 0.000000; -NODES[1796](BODY_FORCE_X,0) = 0.000000; -NODES[1796](BODY_FORCE_Y,0) = -9.810000; -NODES[1796](BODY_FORCE_Z,0) = 0.000000; -NODES[1797](BODY_FORCE_X,0) = 0.000000; -NODES[1797](BODY_FORCE_Y,0) = -9.810000; -NODES[1797](BODY_FORCE_Z,0) = 0.000000; -NODES[1798](BODY_FORCE_X,0) = 0.000000; -NODES[1798](BODY_FORCE_Y,0) = -9.810000; -NODES[1798](BODY_FORCE_Z,0) = 0.000000; -NODES[1799](BODY_FORCE_X,0) = 0.000000; -NODES[1799](BODY_FORCE_Y,0) = -9.810000; -NODES[1799](BODY_FORCE_Z,0) = 0.000000; -NODES[1800](BODY_FORCE_X,0) = 0.000000; -NODES[1800](BODY_FORCE_Y,0) = -9.810000; -NODES[1800](BODY_FORCE_Z,0) = 0.000000; -NODES[1801](BODY_FORCE_X,0) = 0.000000; -NODES[1801](BODY_FORCE_Y,0) = -9.810000; -NODES[1801](BODY_FORCE_Z,0) = 0.000000; -NODES[1802](BODY_FORCE_X,0) = 0.000000; -NODES[1802](BODY_FORCE_Y,0) = -9.810000; -NODES[1802](BODY_FORCE_Z,0) = 0.000000; -NODES[1803](BODY_FORCE_X,0) = 0.000000; -NODES[1803](BODY_FORCE_Y,0) = -9.810000; -NODES[1803](BODY_FORCE_Z,0) = 0.000000; -NODES[1805](BODY_FORCE_X,0) = 0.000000; -NODES[1805](BODY_FORCE_Y,0) = -9.810000; -NODES[1805](BODY_FORCE_Z,0) = 0.000000; -NODES[1806](BODY_FORCE_X,0) = 0.000000; -NODES[1806](BODY_FORCE_Y,0) = -9.810000; -NODES[1806](BODY_FORCE_Z,0) = 0.000000; -NODES[1807](BODY_FORCE_X,0) = 0.000000; -NODES[1807](BODY_FORCE_Y,0) = -9.810000; -NODES[1807](BODY_FORCE_Z,0) = 0.000000; -NODES[1808](BODY_FORCE_X,0) = 0.000000; -NODES[1808](BODY_FORCE_Y,0) = -9.810000; -NODES[1808](BODY_FORCE_Z,0) = 0.000000; -NODES[1809](BODY_FORCE_X,0) = 0.000000; -NODES[1809](BODY_FORCE_Y,0) = -9.810000; -NODES[1809](BODY_FORCE_Z,0) = 0.000000; -NODES[1810](BODY_FORCE_X,0) = 0.000000; -NODES[1810](BODY_FORCE_Y,0) = -9.810000; -NODES[1810](BODY_FORCE_Z,0) = 0.000000; -NODES[1811](BODY_FORCE_X,0) = 0.000000; -NODES[1811](BODY_FORCE_Y,0) = -9.810000; -NODES[1811](BODY_FORCE_Z,0) = 0.000000; -NODES[1812](BODY_FORCE_X,0) = 0.000000; -NODES[1812](BODY_FORCE_Y,0) = -9.810000; -NODES[1812](BODY_FORCE_Z,0) = 0.000000; -NODES[1813](BODY_FORCE_X,0) = 0.000000; -NODES[1813](BODY_FORCE_Y,0) = -9.810000; -NODES[1813](BODY_FORCE_Z,0) = 0.000000; -NODES[1814](BODY_FORCE_X,0) = 0.000000; -NODES[1814](BODY_FORCE_Y,0) = -9.810000; -NODES[1814](BODY_FORCE_Z,0) = 0.000000; -NODES[1815](BODY_FORCE_X,0) = 0.000000; -NODES[1815](BODY_FORCE_Y,0) = -9.810000; -NODES[1815](BODY_FORCE_Z,0) = 0.000000; -NODES[1816](BODY_FORCE_X,0) = 0.000000; -NODES[1816](BODY_FORCE_Y,0) = -9.810000; -NODES[1816](BODY_FORCE_Z,0) = 0.000000; -NODES[1817](BODY_FORCE_X,0) = 0.000000; -NODES[1817](BODY_FORCE_Y,0) = -9.810000; -NODES[1817](BODY_FORCE_Z,0) = 0.000000; -NODES[1818](BODY_FORCE_X,0) = 0.000000; -NODES[1818](BODY_FORCE_Y,0) = -9.810000; -NODES[1818](BODY_FORCE_Z,0) = 0.000000; -NODES[1819](BODY_FORCE_X,0) = 0.000000; -NODES[1819](BODY_FORCE_Y,0) = -9.810000; -NODES[1819](BODY_FORCE_Z,0) = 0.000000; -NODES[1820](BODY_FORCE_X,0) = 0.000000; -NODES[1820](BODY_FORCE_Y,0) = -9.810000; -NODES[1820](BODY_FORCE_Z,0) = 0.000000; -NODES[1821](BODY_FORCE_X,0) = 0.000000; -NODES[1821](BODY_FORCE_Y,0) = -9.810000; -NODES[1821](BODY_FORCE_Z,0) = 0.000000; -NODES[1822](BODY_FORCE_X,0) = 0.000000; -NODES[1822](BODY_FORCE_Y,0) = -9.810000; -NODES[1822](BODY_FORCE_Z,0) = 0.000000; -NODES[1823](BODY_FORCE_X,0) = 0.000000; -NODES[1823](BODY_FORCE_Y,0) = -9.810000; -NODES[1823](BODY_FORCE_Z,0) = 0.000000; -NODES[1824](BODY_FORCE_X,0) = 0.000000; -NODES[1824](BODY_FORCE_Y,0) = -9.810000; -NODES[1824](BODY_FORCE_Z,0) = 0.000000; -NODES[1825](BODY_FORCE_X,0) = 0.000000; -NODES[1825](BODY_FORCE_Y,0) = -9.810000; -NODES[1825](BODY_FORCE_Z,0) = 0.000000; -NODES[1826](BODY_FORCE_X,0) = 0.000000; -NODES[1826](BODY_FORCE_Y,0) = -9.810000; -NODES[1826](BODY_FORCE_Z,0) = 0.000000; -NODES[1827](BODY_FORCE_X,0) = 0.000000; -NODES[1827](BODY_FORCE_Y,0) = -9.810000; -NODES[1827](BODY_FORCE_Z,0) = 0.000000; -NODES[1828](BODY_FORCE_X,0) = 0.000000; -NODES[1828](BODY_FORCE_Y,0) = -9.810000; -NODES[1828](BODY_FORCE_Z,0) = 0.000000; -NODES[1829](BODY_FORCE_X,0) = 0.000000; -NODES[1829](BODY_FORCE_Y,0) = -9.810000; -NODES[1829](BODY_FORCE_Z,0) = 0.000000; -NODES[1830](BODY_FORCE_X,0) = 0.000000; -NODES[1830](BODY_FORCE_Y,0) = -9.810000; -NODES[1830](BODY_FORCE_Z,0) = 0.000000; -NODES[1831](BODY_FORCE_X,0) = 0.000000; -NODES[1831](BODY_FORCE_Y,0) = -9.810000; -NODES[1831](BODY_FORCE_Z,0) = 0.000000; -NODES[1832](BODY_FORCE_X,0) = 0.000000; -NODES[1832](BODY_FORCE_Y,0) = -9.810000; -NODES[1832](BODY_FORCE_Z,0) = 0.000000; -NODES[1833](BODY_FORCE_X,0) = 0.000000; -NODES[1833](BODY_FORCE_Y,0) = -9.810000; -NODES[1833](BODY_FORCE_Z,0) = 0.000000; -NODES[1834](BODY_FORCE_X,0) = 0.000000; -NODES[1834](BODY_FORCE_Y,0) = -9.810000; -NODES[1834](BODY_FORCE_Z,0) = 0.000000; -NODES[1835](BODY_FORCE_X,0) = 0.000000; -NODES[1835](BODY_FORCE_Y,0) = -9.810000; -NODES[1835](BODY_FORCE_Z,0) = 0.000000; -NODES[1836](BODY_FORCE_X,0) = 0.000000; -NODES[1836](BODY_FORCE_Y,0) = -9.810000; -NODES[1836](BODY_FORCE_Z,0) = 0.000000; -NODES[1837](BODY_FORCE_X,0) = 0.000000; -NODES[1837](BODY_FORCE_Y,0) = -9.810000; -NODES[1837](BODY_FORCE_Z,0) = 0.000000; -NODES[1838](BODY_FORCE_X,0) = 0.000000; -NODES[1838](BODY_FORCE_Y,0) = -9.810000; -NODES[1838](BODY_FORCE_Z,0) = 0.000000; -NODES[1840](BODY_FORCE_X,0) = 0.000000; -NODES[1840](BODY_FORCE_Y,0) = -9.810000; -NODES[1840](BODY_FORCE_Z,0) = 0.000000; -NODES[1841](BODY_FORCE_X,0) = 0.000000; -NODES[1841](BODY_FORCE_Y,0) = -9.810000; -NODES[1841](BODY_FORCE_Z,0) = 0.000000; -NODES[1842](BODY_FORCE_X,0) = 0.000000; -NODES[1842](BODY_FORCE_Y,0) = -9.810000; -NODES[1842](BODY_FORCE_Z,0) = 0.000000; -NODES[1843](BODY_FORCE_X,0) = 0.000000; -NODES[1843](BODY_FORCE_Y,0) = -9.810000; -NODES[1843](BODY_FORCE_Z,0) = 0.000000; -NODES[1844](BODY_FORCE_X,0) = 0.000000; -NODES[1844](BODY_FORCE_Y,0) = -9.810000; -NODES[1844](BODY_FORCE_Z,0) = 0.000000; -NODES[1845](BODY_FORCE_X,0) = 0.000000; -NODES[1845](BODY_FORCE_Y,0) = -9.810000; -NODES[1845](BODY_FORCE_Z,0) = 0.000000; -NODES[1846](BODY_FORCE_X,0) = 0.000000; -NODES[1846](BODY_FORCE_Y,0) = -9.810000; -NODES[1846](BODY_FORCE_Z,0) = 0.000000; -NODES[1847](BODY_FORCE_X,0) = 0.000000; -NODES[1847](BODY_FORCE_Y,0) = -9.810000; -NODES[1847](BODY_FORCE_Z,0) = 0.000000; -NODES[1848](BODY_FORCE_X,0) = 0.000000; -NODES[1848](BODY_FORCE_Y,0) = -9.810000; -NODES[1848](BODY_FORCE_Z,0) = 0.000000; -NODES[1849](BODY_FORCE_X,0) = 0.000000; -NODES[1849](BODY_FORCE_Y,0) = -9.810000; -NODES[1849](BODY_FORCE_Z,0) = 0.000000; -NODES[1850](BODY_FORCE_X,0) = 0.000000; -NODES[1850](BODY_FORCE_Y,0) = -9.810000; -NODES[1850](BODY_FORCE_Z,0) = 0.000000; -NODES[1851](BODY_FORCE_X,0) = 0.000000; -NODES[1851](BODY_FORCE_Y,0) = -9.810000; -NODES[1851](BODY_FORCE_Z,0) = 0.000000; -NODES[1852](BODY_FORCE_X,0) = 0.000000; -NODES[1852](BODY_FORCE_Y,0) = -9.810000; -NODES[1852](BODY_FORCE_Z,0) = 0.000000; -NODES[1853](BODY_FORCE_X,0) = 0.000000; -NODES[1853](BODY_FORCE_Y,0) = -9.810000; -NODES[1853](BODY_FORCE_Z,0) = 0.000000; -NODES[1854](BODY_FORCE_X,0) = 0.000000; -NODES[1854](BODY_FORCE_Y,0) = -9.810000; -NODES[1854](BODY_FORCE_Z,0) = 0.000000; -NODES[1855](BODY_FORCE_X,0) = 0.000000; -NODES[1855](BODY_FORCE_Y,0) = -9.810000; -NODES[1855](BODY_FORCE_Z,0) = 0.000000; -NODES[1856](BODY_FORCE_X,0) = 0.000000; -NODES[1856](BODY_FORCE_Y,0) = -9.810000; -NODES[1856](BODY_FORCE_Z,0) = 0.000000; -NODES[1857](BODY_FORCE_X,0) = 0.000000; -NODES[1857](BODY_FORCE_Y,0) = -9.810000; -NODES[1857](BODY_FORCE_Z,0) = 0.000000; -NODES[1858](BODY_FORCE_X,0) = 0.000000; -NODES[1858](BODY_FORCE_Y,0) = -9.810000; -NODES[1858](BODY_FORCE_Z,0) = 0.000000; -NODES[1859](BODY_FORCE_X,0) = 0.000000; -NODES[1859](BODY_FORCE_Y,0) = -9.810000; -NODES[1859](BODY_FORCE_Z,0) = 0.000000; -NODES[1860](BODY_FORCE_X,0) = 0.000000; -NODES[1860](BODY_FORCE_Y,0) = -9.810000; -NODES[1860](BODY_FORCE_Z,0) = 0.000000; -NODES[1861](BODY_FORCE_X,0) = 0.000000; -NODES[1861](BODY_FORCE_Y,0) = -9.810000; -NODES[1861](BODY_FORCE_Z,0) = 0.000000; -NODES[1862](BODY_FORCE_X,0) = 0.000000; -NODES[1862](BODY_FORCE_Y,0) = -9.810000; -NODES[1862](BODY_FORCE_Z,0) = 0.000000; -NODES[1863](BODY_FORCE_X,0) = 0.000000; -NODES[1863](BODY_FORCE_Y,0) = -9.810000; -NODES[1863](BODY_FORCE_Z,0) = 0.000000; -NODES[1864](BODY_FORCE_X,0) = 0.000000; -NODES[1864](BODY_FORCE_Y,0) = -9.810000; -NODES[1864](BODY_FORCE_Z,0) = 0.000000; -NODES[1865](BODY_FORCE_X,0) = 0.000000; -NODES[1865](BODY_FORCE_Y,0) = -9.810000; -NODES[1865](BODY_FORCE_Z,0) = 0.000000; -NODES[1866](BODY_FORCE_X,0) = 0.000000; -NODES[1866](BODY_FORCE_Y,0) = -9.810000; -NODES[1866](BODY_FORCE_Z,0) = 0.000000; -NODES[1867](BODY_FORCE_X,0) = 0.000000; -NODES[1867](BODY_FORCE_Y,0) = -9.810000; -NODES[1867](BODY_FORCE_Z,0) = 0.000000; -NODES[1868](BODY_FORCE_X,0) = 0.000000; -NODES[1868](BODY_FORCE_Y,0) = -9.810000; -NODES[1868](BODY_FORCE_Z,0) = 0.000000; -NODES[1869](BODY_FORCE_X,0) = 0.000000; -NODES[1869](BODY_FORCE_Y,0) = -9.810000; -NODES[1869](BODY_FORCE_Z,0) = 0.000000; -NODES[1870](BODY_FORCE_X,0) = 0.000000; -NODES[1870](BODY_FORCE_Y,0) = -9.810000; -NODES[1870](BODY_FORCE_Z,0) = 0.000000; -NODES[1871](BODY_FORCE_X,0) = 0.000000; -NODES[1871](BODY_FORCE_Y,0) = -9.810000; -NODES[1871](BODY_FORCE_Z,0) = 0.000000; -NODES[1872](BODY_FORCE_X,0) = 0.000000; -NODES[1872](BODY_FORCE_Y,0) = -9.810000; -NODES[1872](BODY_FORCE_Z,0) = 0.000000; -NODES[1874](BODY_FORCE_X,0) = 0.000000; -NODES[1874](BODY_FORCE_Y,0) = -9.810000; -NODES[1874](BODY_FORCE_Z,0) = 0.000000; -NODES[1875](BODY_FORCE_X,0) = 0.000000; -NODES[1875](BODY_FORCE_Y,0) = -9.810000; -NODES[1875](BODY_FORCE_Z,0) = 0.000000; -NODES[1876](BODY_FORCE_X,0) = 0.000000; -NODES[1876](BODY_FORCE_Y,0) = -9.810000; -NODES[1876](BODY_FORCE_Z,0) = 0.000000; -NODES[1877](BODY_FORCE_X,0) = 0.000000; -NODES[1877](BODY_FORCE_Y,0) = -9.810000; -NODES[1877](BODY_FORCE_Z,0) = 0.000000; -NODES[1878](BODY_FORCE_X,0) = 0.000000; -NODES[1878](BODY_FORCE_Y,0) = -9.810000; -NODES[1878](BODY_FORCE_Z,0) = 0.000000; -NODES[1879](BODY_FORCE_X,0) = 0.000000; -NODES[1879](BODY_FORCE_Y,0) = -9.810000; -NODES[1879](BODY_FORCE_Z,0) = 0.000000; -NODES[1880](BODY_FORCE_X,0) = 0.000000; -NODES[1880](BODY_FORCE_Y,0) = -9.810000; -NODES[1880](BODY_FORCE_Z,0) = 0.000000; -NODES[1881](BODY_FORCE_X,0) = 0.000000; -NODES[1881](BODY_FORCE_Y,0) = -9.810000; -NODES[1881](BODY_FORCE_Z,0) = 0.000000; -NODES[1882](BODY_FORCE_X,0) = 0.000000; -NODES[1882](BODY_FORCE_Y,0) = -9.810000; -NODES[1882](BODY_FORCE_Z,0) = 0.000000; -NODES[1883](BODY_FORCE_X,0) = 0.000000; -NODES[1883](BODY_FORCE_Y,0) = -9.810000; -NODES[1883](BODY_FORCE_Z,0) = 0.000000; -NODES[1884](BODY_FORCE_X,0) = 0.000000; -NODES[1884](BODY_FORCE_Y,0) = -9.810000; -NODES[1884](BODY_FORCE_Z,0) = 0.000000; -NODES[1885](BODY_FORCE_X,0) = 0.000000; -NODES[1885](BODY_FORCE_Y,0) = -9.810000; -NODES[1885](BODY_FORCE_Z,0) = 0.000000; -NODES[1886](BODY_FORCE_X,0) = 0.000000; -NODES[1886](BODY_FORCE_Y,0) = -9.810000; -NODES[1886](BODY_FORCE_Z,0) = 0.000000; -NODES[1887](BODY_FORCE_X,0) = 0.000000; -NODES[1887](BODY_FORCE_Y,0) = -9.810000; -NODES[1887](BODY_FORCE_Z,0) = 0.000000; -NODES[1888](BODY_FORCE_X,0) = 0.000000; -NODES[1888](BODY_FORCE_Y,0) = -9.810000; -NODES[1888](BODY_FORCE_Z,0) = 0.000000; -NODES[1889](BODY_FORCE_X,0) = 0.000000; -NODES[1889](BODY_FORCE_Y,0) = -9.810000; -NODES[1889](BODY_FORCE_Z,0) = 0.000000; -NODES[1890](BODY_FORCE_X,0) = 0.000000; -NODES[1890](BODY_FORCE_Y,0) = -9.810000; -NODES[1890](BODY_FORCE_Z,0) = 0.000000; -NODES[1891](BODY_FORCE_X,0) = 0.000000; -NODES[1891](BODY_FORCE_Y,0) = -9.810000; -NODES[1891](BODY_FORCE_Z,0) = 0.000000; -NODES[1892](BODY_FORCE_X,0) = 0.000000; -NODES[1892](BODY_FORCE_Y,0) = -9.810000; -NODES[1892](BODY_FORCE_Z,0) = 0.000000; -NODES[1893](BODY_FORCE_X,0) = 0.000000; -NODES[1893](BODY_FORCE_Y,0) = -9.810000; -NODES[1893](BODY_FORCE_Z,0) = 0.000000; -NODES[1894](BODY_FORCE_X,0) = 0.000000; -NODES[1894](BODY_FORCE_Y,0) = -9.810000; -NODES[1894](BODY_FORCE_Z,0) = 0.000000; -NODES[1895](BODY_FORCE_X,0) = 0.000000; -NODES[1895](BODY_FORCE_Y,0) = -9.810000; -NODES[1895](BODY_FORCE_Z,0) = 0.000000; -NODES[1896](BODY_FORCE_X,0) = 0.000000; -NODES[1896](BODY_FORCE_Y,0) = -9.810000; -NODES[1896](BODY_FORCE_Z,0) = 0.000000; -NODES[1897](BODY_FORCE_X,0) = 0.000000; -NODES[1897](BODY_FORCE_Y,0) = -9.810000; -NODES[1897](BODY_FORCE_Z,0) = 0.000000; -NODES[1898](BODY_FORCE_X,0) = 0.000000; -NODES[1898](BODY_FORCE_Y,0) = -9.810000; -NODES[1898](BODY_FORCE_Z,0) = 0.000000; -NODES[1899](BODY_FORCE_X,0) = 0.000000; -NODES[1899](BODY_FORCE_Y,0) = -9.810000; -NODES[1899](BODY_FORCE_Z,0) = 0.000000; -NODES[1900](BODY_FORCE_X,0) = 0.000000; -NODES[1900](BODY_FORCE_Y,0) = -9.810000; -NODES[1900](BODY_FORCE_Z,0) = 0.000000; -NODES[1901](BODY_FORCE_X,0) = 0.000000; -NODES[1901](BODY_FORCE_Y,0) = -9.810000; -NODES[1901](BODY_FORCE_Z,0) = 0.000000; -NODES[1902](BODY_FORCE_X,0) = 0.000000; -NODES[1902](BODY_FORCE_Y,0) = -9.810000; -NODES[1902](BODY_FORCE_Z,0) = 0.000000; -NODES[1903](BODY_FORCE_X,0) = 0.000000; -NODES[1903](BODY_FORCE_Y,0) = -9.810000; -NODES[1903](BODY_FORCE_Z,0) = 0.000000; -NODES[1904](BODY_FORCE_X,0) = 0.000000; -NODES[1904](BODY_FORCE_Y,0) = -9.810000; -NODES[1904](BODY_FORCE_Z,0) = 0.000000; -NODES[1905](BODY_FORCE_X,0) = 0.000000; -NODES[1905](BODY_FORCE_Y,0) = -9.810000; -NODES[1905](BODY_FORCE_Z,0) = 0.000000; -NODES[1906](BODY_FORCE_X,0) = 0.000000; -NODES[1906](BODY_FORCE_Y,0) = -9.810000; -NODES[1906](BODY_FORCE_Z,0) = 0.000000; -NODES[1907](BODY_FORCE_X,0) = 0.000000; -NODES[1907](BODY_FORCE_Y,0) = -9.810000; -NODES[1907](BODY_FORCE_Z,0) = 0.000000; -NODES[1908](BODY_FORCE_X,0) = 0.000000; -NODES[1908](BODY_FORCE_Y,0) = -9.810000; -NODES[1908](BODY_FORCE_Z,0) = 0.000000; -NODES[1910](BODY_FORCE_X,0) = 0.000000; -NODES[1910](BODY_FORCE_Y,0) = -9.810000; -NODES[1910](BODY_FORCE_Z,0) = 0.000000; -NODES[1911](BODY_FORCE_X,0) = 0.000000; -NODES[1911](BODY_FORCE_Y,0) = -9.810000; -NODES[1911](BODY_FORCE_Z,0) = 0.000000; -NODES[1912](BODY_FORCE_X,0) = 0.000000; -NODES[1912](BODY_FORCE_Y,0) = -9.810000; -NODES[1912](BODY_FORCE_Z,0) = 0.000000; -NODES[1913](BODY_FORCE_X,0) = 0.000000; -NODES[1913](BODY_FORCE_Y,0) = -9.810000; -NODES[1913](BODY_FORCE_Z,0) = 0.000000; -NODES[1914](BODY_FORCE_X,0) = 0.000000; -NODES[1914](BODY_FORCE_Y,0) = -9.810000; -NODES[1914](BODY_FORCE_Z,0) = 0.000000; -NODES[1915](BODY_FORCE_X,0) = 0.000000; -NODES[1915](BODY_FORCE_Y,0) = -9.810000; -NODES[1915](BODY_FORCE_Z,0) = 0.000000; -NODES[1916](BODY_FORCE_X,0) = 0.000000; -NODES[1916](BODY_FORCE_Y,0) = -9.810000; -NODES[1916](BODY_FORCE_Z,0) = 0.000000; -NODES[1917](BODY_FORCE_X,0) = 0.000000; -NODES[1917](BODY_FORCE_Y,0) = -9.810000; -NODES[1917](BODY_FORCE_Z,0) = 0.000000; -NODES[1918](BODY_FORCE_X,0) = 0.000000; -NODES[1918](BODY_FORCE_Y,0) = -9.810000; -NODES[1918](BODY_FORCE_Z,0) = 0.000000; -NODES[1919](BODY_FORCE_X,0) = 0.000000; -NODES[1919](BODY_FORCE_Y,0) = -9.810000; -NODES[1919](BODY_FORCE_Z,0) = 0.000000; -NODES[1920](BODY_FORCE_X,0) = 0.000000; -NODES[1920](BODY_FORCE_Y,0) = -9.810000; -NODES[1920](BODY_FORCE_Z,0) = 0.000000; -NODES[1921](BODY_FORCE_X,0) = 0.000000; -NODES[1921](BODY_FORCE_Y,0) = -9.810000; -NODES[1921](BODY_FORCE_Z,0) = 0.000000; -NODES[1922](BODY_FORCE_X,0) = 0.000000; -NODES[1922](BODY_FORCE_Y,0) = -9.810000; -NODES[1922](BODY_FORCE_Z,0) = 0.000000; -NODES[1923](BODY_FORCE_X,0) = 0.000000; -NODES[1923](BODY_FORCE_Y,0) = -9.810000; -NODES[1923](BODY_FORCE_Z,0) = 0.000000; -NODES[1924](BODY_FORCE_X,0) = 0.000000; -NODES[1924](BODY_FORCE_Y,0) = -9.810000; -NODES[1924](BODY_FORCE_Z,0) = 0.000000; -NODES[1925](BODY_FORCE_X,0) = 0.000000; -NODES[1925](BODY_FORCE_Y,0) = -9.810000; -NODES[1925](BODY_FORCE_Z,0) = 0.000000; -NODES[1926](BODY_FORCE_X,0) = 0.000000; -NODES[1926](BODY_FORCE_Y,0) = -9.810000; -NODES[1926](BODY_FORCE_Z,0) = 0.000000; -NODES[1927](BODY_FORCE_X,0) = 0.000000; -NODES[1927](BODY_FORCE_Y,0) = -9.810000; -NODES[1927](BODY_FORCE_Z,0) = 0.000000; -NODES[1928](BODY_FORCE_X,0) = 0.000000; -NODES[1928](BODY_FORCE_Y,0) = -9.810000; -NODES[1928](BODY_FORCE_Z,0) = 0.000000; -NODES[1929](BODY_FORCE_X,0) = 0.000000; -NODES[1929](BODY_FORCE_Y,0) = -9.810000; -NODES[1929](BODY_FORCE_Z,0) = 0.000000; -NODES[1930](BODY_FORCE_X,0) = 0.000000; -NODES[1930](BODY_FORCE_Y,0) = -9.810000; -NODES[1930](BODY_FORCE_Z,0) = 0.000000; -NODES[1931](BODY_FORCE_X,0) = 0.000000; -NODES[1931](BODY_FORCE_Y,0) = -9.810000; -NODES[1931](BODY_FORCE_Z,0) = 0.000000; -NODES[1932](BODY_FORCE_X,0) = 0.000000; -NODES[1932](BODY_FORCE_Y,0) = -9.810000; -NODES[1932](BODY_FORCE_Z,0) = 0.000000; -NODES[1933](BODY_FORCE_X,0) = 0.000000; -NODES[1933](BODY_FORCE_Y,0) = -9.810000; -NODES[1933](BODY_FORCE_Z,0) = 0.000000; -NODES[1934](BODY_FORCE_X,0) = 0.000000; -NODES[1934](BODY_FORCE_Y,0) = -9.810000; -NODES[1934](BODY_FORCE_Z,0) = 0.000000; -NODES[1935](BODY_FORCE_X,0) = 0.000000; -NODES[1935](BODY_FORCE_Y,0) = -9.810000; -NODES[1935](BODY_FORCE_Z,0) = 0.000000; -NODES[1936](BODY_FORCE_X,0) = 0.000000; -NODES[1936](BODY_FORCE_Y,0) = -9.810000; -NODES[1936](BODY_FORCE_Z,0) = 0.000000; -NODES[1937](BODY_FORCE_X,0) = 0.000000; -NODES[1937](BODY_FORCE_Y,0) = -9.810000; -NODES[1937](BODY_FORCE_Z,0) = 0.000000; -NODES[1938](BODY_FORCE_X,0) = 0.000000; -NODES[1938](BODY_FORCE_Y,0) = -9.810000; -NODES[1938](BODY_FORCE_Z,0) = 0.000000; -NODES[1939](BODY_FORCE_X,0) = 0.000000; -NODES[1939](BODY_FORCE_Y,0) = -9.810000; -NODES[1939](BODY_FORCE_Z,0) = 0.000000; -NODES[1940](BODY_FORCE_X,0) = 0.000000; -NODES[1940](BODY_FORCE_Y,0) = -9.810000; -NODES[1940](BODY_FORCE_Z,0) = 0.000000; -NODES[1941](BODY_FORCE_X,0) = 0.000000; -NODES[1941](BODY_FORCE_Y,0) = -9.810000; -NODES[1941](BODY_FORCE_Z,0) = 0.000000; -NODES[1942](BODY_FORCE_X,0) = 0.000000; -NODES[1942](BODY_FORCE_Y,0) = -9.810000; -NODES[1942](BODY_FORCE_Z,0) = 0.000000; -NODES[1944](BODY_FORCE_X,0) = 0.000000; -NODES[1944](BODY_FORCE_Y,0) = -9.810000; -NODES[1944](BODY_FORCE_Z,0) = 0.000000; -NODES[1945](BODY_FORCE_X,0) = 0.000000; -NODES[1945](BODY_FORCE_Y,0) = -9.810000; -NODES[1945](BODY_FORCE_Z,0) = 0.000000; -NODES[1946](BODY_FORCE_X,0) = 0.000000; -NODES[1946](BODY_FORCE_Y,0) = -9.810000; -NODES[1946](BODY_FORCE_Z,0) = 0.000000; -NODES[1947](BODY_FORCE_X,0) = 0.000000; -NODES[1947](BODY_FORCE_Y,0) = -9.810000; -NODES[1947](BODY_FORCE_Z,0) = 0.000000; -NODES[1948](BODY_FORCE_X,0) = 0.000000; -NODES[1948](BODY_FORCE_Y,0) = -9.810000; -NODES[1948](BODY_FORCE_Z,0) = 0.000000; -NODES[1949](BODY_FORCE_X,0) = 0.000000; -NODES[1949](BODY_FORCE_Y,0) = -9.810000; -NODES[1949](BODY_FORCE_Z,0) = 0.000000; -NODES[1950](BODY_FORCE_X,0) = 0.000000; -NODES[1950](BODY_FORCE_Y,0) = -9.810000; -NODES[1950](BODY_FORCE_Z,0) = 0.000000; -NODES[1951](BODY_FORCE_X,0) = 0.000000; -NODES[1951](BODY_FORCE_Y,0) = -9.810000; -NODES[1951](BODY_FORCE_Z,0) = 0.000000; -NODES[1952](BODY_FORCE_X,0) = 0.000000; -NODES[1952](BODY_FORCE_Y,0) = -9.810000; -NODES[1952](BODY_FORCE_Z,0) = 0.000000; -NODES[1953](BODY_FORCE_X,0) = 0.000000; -NODES[1953](BODY_FORCE_Y,0) = -9.810000; -NODES[1953](BODY_FORCE_Z,0) = 0.000000; -NODES[1954](BODY_FORCE_X,0) = 0.000000; -NODES[1954](BODY_FORCE_Y,0) = -9.810000; -NODES[1954](BODY_FORCE_Z,0) = 0.000000; -NODES[1955](BODY_FORCE_X,0) = 0.000000; -NODES[1955](BODY_FORCE_Y,0) = -9.810000; -NODES[1955](BODY_FORCE_Z,0) = 0.000000; -NODES[1956](BODY_FORCE_X,0) = 0.000000; -NODES[1956](BODY_FORCE_Y,0) = -9.810000; -NODES[1956](BODY_FORCE_Z,0) = 0.000000; -NODES[1957](BODY_FORCE_X,0) = 0.000000; -NODES[1957](BODY_FORCE_Y,0) = -9.810000; -NODES[1957](BODY_FORCE_Z,0) = 0.000000; -NODES[1958](BODY_FORCE_X,0) = 0.000000; -NODES[1958](BODY_FORCE_Y,0) = -9.810000; -NODES[1958](BODY_FORCE_Z,0) = 0.000000; -NODES[1959](BODY_FORCE_X,0) = 0.000000; -NODES[1959](BODY_FORCE_Y,0) = -9.810000; -NODES[1959](BODY_FORCE_Z,0) = 0.000000; -NODES[1960](BODY_FORCE_X,0) = 0.000000; -NODES[1960](BODY_FORCE_Y,0) = -9.810000; -NODES[1960](BODY_FORCE_Z,0) = 0.000000; -NODES[1961](BODY_FORCE_X,0) = 0.000000; -NODES[1961](BODY_FORCE_Y,0) = -9.810000; -NODES[1961](BODY_FORCE_Z,0) = 0.000000; -NODES[1962](BODY_FORCE_X,0) = 0.000000; -NODES[1962](BODY_FORCE_Y,0) = -9.810000; -NODES[1962](BODY_FORCE_Z,0) = 0.000000; -NODES[1963](BODY_FORCE_X,0) = 0.000000; -NODES[1963](BODY_FORCE_Y,0) = -9.810000; -NODES[1963](BODY_FORCE_Z,0) = 0.000000; -NODES[1964](BODY_FORCE_X,0) = 0.000000; -NODES[1964](BODY_FORCE_Y,0) = -9.810000; -NODES[1964](BODY_FORCE_Z,0) = 0.000000; -NODES[1965](BODY_FORCE_X,0) = 0.000000; -NODES[1965](BODY_FORCE_Y,0) = -9.810000; -NODES[1965](BODY_FORCE_Z,0) = 0.000000; -NODES[1966](BODY_FORCE_X,0) = 0.000000; -NODES[1966](BODY_FORCE_Y,0) = -9.810000; -NODES[1966](BODY_FORCE_Z,0) = 0.000000; -NODES[1967](BODY_FORCE_X,0) = 0.000000; -NODES[1967](BODY_FORCE_Y,0) = -9.810000; -NODES[1967](BODY_FORCE_Z,0) = 0.000000; -NODES[1968](BODY_FORCE_X,0) = 0.000000; -NODES[1968](BODY_FORCE_Y,0) = -9.810000; -NODES[1968](BODY_FORCE_Z,0) = 0.000000; -NODES[1969](BODY_FORCE_X,0) = 0.000000; -NODES[1969](BODY_FORCE_Y,0) = -9.810000; -NODES[1969](BODY_FORCE_Z,0) = 0.000000; -NODES[1970](BODY_FORCE_X,0) = 0.000000; -NODES[1970](BODY_FORCE_Y,0) = -9.810000; -NODES[1970](BODY_FORCE_Z,0) = 0.000000; -NODES[1971](BODY_FORCE_X,0) = 0.000000; -NODES[1971](BODY_FORCE_Y,0) = -9.810000; -NODES[1971](BODY_FORCE_Z,0) = 0.000000; -NODES[1972](BODY_FORCE_X,0) = 0.000000; -NODES[1972](BODY_FORCE_Y,0) = -9.810000; -NODES[1972](BODY_FORCE_Z,0) = 0.000000; -NODES[1973](BODY_FORCE_X,0) = 0.000000; -NODES[1973](BODY_FORCE_Y,0) = -9.810000; -NODES[1973](BODY_FORCE_Z,0) = 0.000000; -NODES[1974](BODY_FORCE_X,0) = 0.000000; -NODES[1974](BODY_FORCE_Y,0) = -9.810000; -NODES[1974](BODY_FORCE_Z,0) = 0.000000; -NODES[1976](BODY_FORCE_X,0) = 0.000000; -NODES[1976](BODY_FORCE_Y,0) = -9.810000; -NODES[1976](BODY_FORCE_Z,0) = 0.000000; -NODES[1977](BODY_FORCE_X,0) = 0.000000; -NODES[1977](BODY_FORCE_Y,0) = -9.810000; -NODES[1977](BODY_FORCE_Z,0) = 0.000000; -NODES[1978](BODY_FORCE_X,0) = 0.000000; -NODES[1978](BODY_FORCE_Y,0) = -9.810000; -NODES[1978](BODY_FORCE_Z,0) = 0.000000; -NODES[1979](BODY_FORCE_X,0) = 0.000000; -NODES[1979](BODY_FORCE_Y,0) = -9.810000; -NODES[1979](BODY_FORCE_Z,0) = 0.000000; -NODES[1980](BODY_FORCE_X,0) = 0.000000; -NODES[1980](BODY_FORCE_Y,0) = -9.810000; -NODES[1980](BODY_FORCE_Z,0) = 0.000000; -NODES[1981](BODY_FORCE_X,0) = 0.000000; -NODES[1981](BODY_FORCE_Y,0) = -9.810000; -NODES[1981](BODY_FORCE_Z,0) = 0.000000; -NODES[1982](BODY_FORCE_X,0) = 0.000000; -NODES[1982](BODY_FORCE_Y,0) = -9.810000; -NODES[1982](BODY_FORCE_Z,0) = 0.000000; -NODES[1983](BODY_FORCE_X,0) = 0.000000; -NODES[1983](BODY_FORCE_Y,0) = -9.810000; -NODES[1983](BODY_FORCE_Z,0) = 0.000000; -NODES[1984](BODY_FORCE_X,0) = 0.000000; -NODES[1984](BODY_FORCE_Y,0) = -9.810000; -NODES[1984](BODY_FORCE_Z,0) = 0.000000; -NODES[1985](BODY_FORCE_X,0) = 0.000000; -NODES[1985](BODY_FORCE_Y,0) = -9.810000; -NODES[1985](BODY_FORCE_Z,0) = 0.000000; -NODES[1986](BODY_FORCE_X,0) = 0.000000; -NODES[1986](BODY_FORCE_Y,0) = -9.810000; -NODES[1986](BODY_FORCE_Z,0) = 0.000000; -NODES[1987](BODY_FORCE_X,0) = 0.000000; -NODES[1987](BODY_FORCE_Y,0) = -9.810000; -NODES[1987](BODY_FORCE_Z,0) = 0.000000; -NODES[1988](BODY_FORCE_X,0) = 0.000000; -NODES[1988](BODY_FORCE_Y,0) = -9.810000; -NODES[1988](BODY_FORCE_Z,0) = 0.000000; -NODES[1989](BODY_FORCE_X,0) = 0.000000; -NODES[1989](BODY_FORCE_Y,0) = -9.810000; -NODES[1989](BODY_FORCE_Z,0) = 0.000000; -NODES[1990](BODY_FORCE_X,0) = 0.000000; -NODES[1990](BODY_FORCE_Y,0) = -9.810000; -NODES[1990](BODY_FORCE_Z,0) = 0.000000; -NODES[1991](BODY_FORCE_X,0) = 0.000000; -NODES[1991](BODY_FORCE_Y,0) = -9.810000; -NODES[1991](BODY_FORCE_Z,0) = 0.000000; -NODES[1992](BODY_FORCE_X,0) = 0.000000; -NODES[1992](BODY_FORCE_Y,0) = -9.810000; -NODES[1992](BODY_FORCE_Z,0) = 0.000000; -NODES[1993](BODY_FORCE_X,0) = 0.000000; -NODES[1993](BODY_FORCE_Y,0) = -9.810000; -NODES[1993](BODY_FORCE_Z,0) = 0.000000; -NODES[1994](BODY_FORCE_X,0) = 0.000000; -NODES[1994](BODY_FORCE_Y,0) = -9.810000; -NODES[1994](BODY_FORCE_Z,0) = 0.000000; -NODES[1995](BODY_FORCE_X,0) = 0.000000; -NODES[1995](BODY_FORCE_Y,0) = -9.810000; -NODES[1995](BODY_FORCE_Z,0) = 0.000000; -NODES[1996](BODY_FORCE_X,0) = 0.000000; -NODES[1996](BODY_FORCE_Y,0) = -9.810000; -NODES[1996](BODY_FORCE_Z,0) = 0.000000; -NODES[1997](BODY_FORCE_X,0) = 0.000000; -NODES[1997](BODY_FORCE_Y,0) = -9.810000; -NODES[1997](BODY_FORCE_Z,0) = 0.000000; -NODES[1998](BODY_FORCE_X,0) = 0.000000; -NODES[1998](BODY_FORCE_Y,0) = -9.810000; -NODES[1998](BODY_FORCE_Z,0) = 0.000000; -NODES[1999](BODY_FORCE_X,0) = 0.000000; -NODES[1999](BODY_FORCE_Y,0) = -9.810000; -NODES[1999](BODY_FORCE_Z,0) = 0.000000; -NODES[2000](BODY_FORCE_X,0) = 0.000000; -NODES[2000](BODY_FORCE_Y,0) = -9.810000; -NODES[2000](BODY_FORCE_Z,0) = 0.000000; -NODES[2001](BODY_FORCE_X,0) = 0.000000; -NODES[2001](BODY_FORCE_Y,0) = -9.810000; -NODES[2001](BODY_FORCE_Z,0) = 0.000000; -NODES[2002](BODY_FORCE_X,0) = 0.000000; -NODES[2002](BODY_FORCE_Y,0) = -9.810000; -NODES[2002](BODY_FORCE_Z,0) = 0.000000; -NODES[2003](BODY_FORCE_X,0) = 0.000000; -NODES[2003](BODY_FORCE_Y,0) = -9.810000; -NODES[2003](BODY_FORCE_Z,0) = 0.000000; -NODES[2004](BODY_FORCE_X,0) = 0.000000; -NODES[2004](BODY_FORCE_Y,0) = -9.810000; -NODES[2004](BODY_FORCE_Z,0) = 0.000000; -NODES[2005](BODY_FORCE_X,0) = 0.000000; -NODES[2005](BODY_FORCE_Y,0) = -9.810000; -NODES[2005](BODY_FORCE_Z,0) = 0.000000; -NODES[2006](BODY_FORCE_X,0) = 0.000000; -NODES[2006](BODY_FORCE_Y,0) = -9.810000; -NODES[2006](BODY_FORCE_Z,0) = 0.000000; -NODES[2007](BODY_FORCE_X,0) = 0.000000; -NODES[2007](BODY_FORCE_Y,0) = -9.810000; -NODES[2007](BODY_FORCE_Z,0) = 0.000000; -NODES[2008](BODY_FORCE_X,0) = 0.000000; -NODES[2008](BODY_FORCE_Y,0) = -9.810000; -NODES[2008](BODY_FORCE_Z,0) = 0.000000; -NODES[2009](BODY_FORCE_X,0) = 0.000000; -NODES[2009](BODY_FORCE_Y,0) = -9.810000; -NODES[2009](BODY_FORCE_Z,0) = 0.000000; -NODES[2011](BODY_FORCE_X,0) = 0.000000; -NODES[2011](BODY_FORCE_Y,0) = -9.810000; -NODES[2011](BODY_FORCE_Z,0) = 0.000000; -NODES[2012](BODY_FORCE_X,0) = 0.000000; -NODES[2012](BODY_FORCE_Y,0) = -9.810000; -NODES[2012](BODY_FORCE_Z,0) = 0.000000; -NODES[2013](BODY_FORCE_X,0) = 0.000000; -NODES[2013](BODY_FORCE_Y,0) = -9.810000; -NODES[2013](BODY_FORCE_Z,0) = 0.000000; -NODES[2014](BODY_FORCE_X,0) = 0.000000; -NODES[2014](BODY_FORCE_Y,0) = -9.810000; -NODES[2014](BODY_FORCE_Z,0) = 0.000000; -NODES[2015](BODY_FORCE_X,0) = 0.000000; -NODES[2015](BODY_FORCE_Y,0) = -9.810000; -NODES[2015](BODY_FORCE_Z,0) = 0.000000; -NODES[2016](BODY_FORCE_X,0) = 0.000000; -NODES[2016](BODY_FORCE_Y,0) = -9.810000; -NODES[2016](BODY_FORCE_Z,0) = 0.000000; -NODES[2017](BODY_FORCE_X,0) = 0.000000; -NODES[2017](BODY_FORCE_Y,0) = -9.810000; -NODES[2017](BODY_FORCE_Z,0) = 0.000000; -NODES[2018](BODY_FORCE_X,0) = 0.000000; -NODES[2018](BODY_FORCE_Y,0) = -9.810000; -NODES[2018](BODY_FORCE_Z,0) = 0.000000; -NODES[2019](BODY_FORCE_X,0) = 0.000000; -NODES[2019](BODY_FORCE_Y,0) = -9.810000; -NODES[2019](BODY_FORCE_Z,0) = 0.000000; -NODES[2020](BODY_FORCE_X,0) = 0.000000; -NODES[2020](BODY_FORCE_Y,0) = -9.810000; -NODES[2020](BODY_FORCE_Z,0) = 0.000000; -NODES[2021](BODY_FORCE_X,0) = 0.000000; -NODES[2021](BODY_FORCE_Y,0) = -9.810000; -NODES[2021](BODY_FORCE_Z,0) = 0.000000; -NODES[2022](BODY_FORCE_X,0) = 0.000000; -NODES[2022](BODY_FORCE_Y,0) = -9.810000; -NODES[2022](BODY_FORCE_Z,0) = 0.000000; -NODES[2023](BODY_FORCE_X,0) = 0.000000; -NODES[2023](BODY_FORCE_Y,0) = -9.810000; -NODES[2023](BODY_FORCE_Z,0) = 0.000000; -NODES[2024](BODY_FORCE_X,0) = 0.000000; -NODES[2024](BODY_FORCE_Y,0) = -9.810000; -NODES[2024](BODY_FORCE_Z,0) = 0.000000; -NODES[2025](BODY_FORCE_X,0) = 0.000000; -NODES[2025](BODY_FORCE_Y,0) = -9.810000; -NODES[2025](BODY_FORCE_Z,0) = 0.000000; -NODES[2026](BODY_FORCE_X,0) = 0.000000; -NODES[2026](BODY_FORCE_Y,0) = -9.810000; -NODES[2026](BODY_FORCE_Z,0) = 0.000000; -NODES[2027](BODY_FORCE_X,0) = 0.000000; -NODES[2027](BODY_FORCE_Y,0) = -9.810000; -NODES[2027](BODY_FORCE_Z,0) = 0.000000; -NODES[2028](BODY_FORCE_X,0) = 0.000000; -NODES[2028](BODY_FORCE_Y,0) = -9.810000; -NODES[2028](BODY_FORCE_Z,0) = 0.000000; -NODES[2029](BODY_FORCE_X,0) = 0.000000; -NODES[2029](BODY_FORCE_Y,0) = -9.810000; -NODES[2029](BODY_FORCE_Z,0) = 0.000000; -NODES[2030](BODY_FORCE_X,0) = 0.000000; -NODES[2030](BODY_FORCE_Y,0) = -9.810000; -NODES[2030](BODY_FORCE_Z,0) = 0.000000; -NODES[2031](BODY_FORCE_X,0) = 0.000000; -NODES[2031](BODY_FORCE_Y,0) = -9.810000; -NODES[2031](BODY_FORCE_Z,0) = 0.000000; -NODES[2032](BODY_FORCE_X,0) = 0.000000; -NODES[2032](BODY_FORCE_Y,0) = -9.810000; -NODES[2032](BODY_FORCE_Z,0) = 0.000000; -NODES[2033](BODY_FORCE_X,0) = 0.000000; -NODES[2033](BODY_FORCE_Y,0) = -9.810000; -NODES[2033](BODY_FORCE_Z,0) = 0.000000; -NODES[2034](BODY_FORCE_X,0) = 0.000000; -NODES[2034](BODY_FORCE_Y,0) = -9.810000; -NODES[2034](BODY_FORCE_Z,0) = 0.000000; -NODES[2035](BODY_FORCE_X,0) = 0.000000; -NODES[2035](BODY_FORCE_Y,0) = -9.810000; -NODES[2035](BODY_FORCE_Z,0) = 0.000000; -NODES[2036](BODY_FORCE_X,0) = 0.000000; -NODES[2036](BODY_FORCE_Y,0) = -9.810000; -NODES[2036](BODY_FORCE_Z,0) = 0.000000; -NODES[2037](BODY_FORCE_X,0) = 0.000000; -NODES[2037](BODY_FORCE_Y,0) = -9.810000; -NODES[2037](BODY_FORCE_Z,0) = 0.000000; -NODES[2038](BODY_FORCE_X,0) = 0.000000; -NODES[2038](BODY_FORCE_Y,0) = -9.810000; -NODES[2038](BODY_FORCE_Z,0) = 0.000000; -NODES[2039](BODY_FORCE_X,0) = 0.000000; -NODES[2039](BODY_FORCE_Y,0) = -9.810000; -NODES[2039](BODY_FORCE_Z,0) = 0.000000; -NODES[2040](BODY_FORCE_X,0) = 0.000000; -NODES[2040](BODY_FORCE_Y,0) = -9.810000; -NODES[2040](BODY_FORCE_Z,0) = 0.000000; -NODES[2041](BODY_FORCE_X,0) = 0.000000; -NODES[2041](BODY_FORCE_Y,0) = -9.810000; -NODES[2041](BODY_FORCE_Z,0) = 0.000000; -NODES[2042](BODY_FORCE_X,0) = 0.000000; -NODES[2042](BODY_FORCE_Y,0) = -9.810000; -NODES[2042](BODY_FORCE_Z,0) = 0.000000; -NODES[2044](BODY_FORCE_X,0) = 0.000000; -NODES[2044](BODY_FORCE_Y,0) = -9.810000; -NODES[2044](BODY_FORCE_Z,0) = 0.000000; -NODES[2045](BODY_FORCE_X,0) = 0.000000; -NODES[2045](BODY_FORCE_Y,0) = -9.810000; -NODES[2045](BODY_FORCE_Z,0) = 0.000000; -NODES[2046](BODY_FORCE_X,0) = 0.000000; -NODES[2046](BODY_FORCE_Y,0) = -9.810000; -NODES[2046](BODY_FORCE_Z,0) = 0.000000; -NODES[2047](BODY_FORCE_X,0) = 0.000000; -NODES[2047](BODY_FORCE_Y,0) = -9.810000; -NODES[2047](BODY_FORCE_Z,0) = 0.000000; -NODES[2048](BODY_FORCE_X,0) = 0.000000; -NODES[2048](BODY_FORCE_Y,0) = -9.810000; -NODES[2048](BODY_FORCE_Z,0) = 0.000000; -NODES[2049](BODY_FORCE_X,0) = 0.000000; -NODES[2049](BODY_FORCE_Y,0) = -9.810000; -NODES[2049](BODY_FORCE_Z,0) = 0.000000; -NODES[2050](BODY_FORCE_X,0) = 0.000000; -NODES[2050](BODY_FORCE_Y,0) = -9.810000; -NODES[2050](BODY_FORCE_Z,0) = 0.000000; -NODES[2051](BODY_FORCE_X,0) = 0.000000; -NODES[2051](BODY_FORCE_Y,0) = -9.810000; -NODES[2051](BODY_FORCE_Z,0) = 0.000000; -NODES[2052](BODY_FORCE_X,0) = 0.000000; -NODES[2052](BODY_FORCE_Y,0) = -9.810000; -NODES[2052](BODY_FORCE_Z,0) = 0.000000; -NODES[2053](BODY_FORCE_X,0) = 0.000000; -NODES[2053](BODY_FORCE_Y,0) = -9.810000; -NODES[2053](BODY_FORCE_Z,0) = 0.000000; -NODES[2054](BODY_FORCE_X,0) = 0.000000; -NODES[2054](BODY_FORCE_Y,0) = -9.810000; -NODES[2054](BODY_FORCE_Z,0) = 0.000000; -NODES[2055](BODY_FORCE_X,0) = 0.000000; -NODES[2055](BODY_FORCE_Y,0) = -9.810000; -NODES[2055](BODY_FORCE_Z,0) = 0.000000; -NODES[2056](BODY_FORCE_X,0) = 0.000000; -NODES[2056](BODY_FORCE_Y,0) = -9.810000; -NODES[2056](BODY_FORCE_Z,0) = 0.000000; -NODES[2057](BODY_FORCE_X,0) = 0.000000; -NODES[2057](BODY_FORCE_Y,0) = -9.810000; -NODES[2057](BODY_FORCE_Z,0) = 0.000000; -NODES[2058](BODY_FORCE_X,0) = 0.000000; -NODES[2058](BODY_FORCE_Y,0) = -9.810000; -NODES[2058](BODY_FORCE_Z,0) = 0.000000; -NODES[2059](BODY_FORCE_X,0) = 0.000000; -NODES[2059](BODY_FORCE_Y,0) = -9.810000; -NODES[2059](BODY_FORCE_Z,0) = 0.000000; -NODES[2060](BODY_FORCE_X,0) = 0.000000; -NODES[2060](BODY_FORCE_Y,0) = -9.810000; -NODES[2060](BODY_FORCE_Z,0) = 0.000000; -NODES[2061](BODY_FORCE_X,0) = 0.000000; -NODES[2061](BODY_FORCE_Y,0) = -9.810000; -NODES[2061](BODY_FORCE_Z,0) = 0.000000; -NODES[2062](BODY_FORCE_X,0) = 0.000000; -NODES[2062](BODY_FORCE_Y,0) = -9.810000; -NODES[2062](BODY_FORCE_Z,0) = 0.000000; -NODES[2063](BODY_FORCE_X,0) = 0.000000; -NODES[2063](BODY_FORCE_Y,0) = -9.810000; -NODES[2063](BODY_FORCE_Z,0) = 0.000000; -NODES[2064](BODY_FORCE_X,0) = 0.000000; -NODES[2064](BODY_FORCE_Y,0) = -9.810000; -NODES[2064](BODY_FORCE_Z,0) = 0.000000; -NODES[2065](BODY_FORCE_X,0) = 0.000000; -NODES[2065](BODY_FORCE_Y,0) = -9.810000; -NODES[2065](BODY_FORCE_Z,0) = 0.000000; -NODES[2066](BODY_FORCE_X,0) = 0.000000; -NODES[2066](BODY_FORCE_Y,0) = -9.810000; -NODES[2066](BODY_FORCE_Z,0) = 0.000000; -NODES[2067](BODY_FORCE_X,0) = 0.000000; -NODES[2067](BODY_FORCE_Y,0) = -9.810000; -NODES[2067](BODY_FORCE_Z,0) = 0.000000; -NODES[2068](BODY_FORCE_X,0) = 0.000000; -NODES[2068](BODY_FORCE_Y,0) = -9.810000; -NODES[2068](BODY_FORCE_Z,0) = 0.000000; -NODES[2069](BODY_FORCE_X,0) = 0.000000; -NODES[2069](BODY_FORCE_Y,0) = -9.810000; -NODES[2069](BODY_FORCE_Z,0) = 0.000000; -NODES[2070](BODY_FORCE_X,0) = 0.000000; -NODES[2070](BODY_FORCE_Y,0) = -9.810000; -NODES[2070](BODY_FORCE_Z,0) = 0.000000; -NODES[2071](BODY_FORCE_X,0) = 0.000000; -NODES[2071](BODY_FORCE_Y,0) = -9.810000; -NODES[2071](BODY_FORCE_Z,0) = 0.000000; -NODES[2072](BODY_FORCE_X,0) = 0.000000; -NODES[2072](BODY_FORCE_Y,0) = -9.810000; -NODES[2072](BODY_FORCE_Z,0) = 0.000000; -NODES[2073](BODY_FORCE_X,0) = 0.000000; -NODES[2073](BODY_FORCE_Y,0) = -9.810000; -NODES[2073](BODY_FORCE_Z,0) = 0.000000; -NODES[2074](BODY_FORCE_X,0) = 0.000000; -NODES[2074](BODY_FORCE_Y,0) = -9.810000; -NODES[2074](BODY_FORCE_Z,0) = 0.000000; -NODES[2075](BODY_FORCE_X,0) = 0.000000; -NODES[2075](BODY_FORCE_Y,0) = -9.810000; -NODES[2075](BODY_FORCE_Z,0) = 0.000000; -NODES[2076](BODY_FORCE_X,0) = 0.000000; -NODES[2076](BODY_FORCE_Y,0) = -9.810000; -NODES[2076](BODY_FORCE_Z,0) = 0.000000; -NODES[2078](BODY_FORCE_X,0) = 0.000000; -NODES[2078](BODY_FORCE_Y,0) = -9.810000; -NODES[2078](BODY_FORCE_Z,0) = 0.000000; -NODES[2079](BODY_FORCE_X,0) = 0.000000; -NODES[2079](BODY_FORCE_Y,0) = -9.810000; -NODES[2079](BODY_FORCE_Z,0) = 0.000000; -NODES[2080](BODY_FORCE_X,0) = 0.000000; -NODES[2080](BODY_FORCE_Y,0) = -9.810000; -NODES[2080](BODY_FORCE_Z,0) = 0.000000; -NODES[2081](BODY_FORCE_X,0) = 0.000000; -NODES[2081](BODY_FORCE_Y,0) = -9.810000; -NODES[2081](BODY_FORCE_Z,0) = 0.000000; -NODES[2082](BODY_FORCE_X,0) = 0.000000; -NODES[2082](BODY_FORCE_Y,0) = -9.810000; -NODES[2082](BODY_FORCE_Z,0) = 0.000000; -NODES[2083](BODY_FORCE_X,0) = 0.000000; -NODES[2083](BODY_FORCE_Y,0) = -9.810000; -NODES[2083](BODY_FORCE_Z,0) = 0.000000; -NODES[2084](BODY_FORCE_X,0) = 0.000000; -NODES[2084](BODY_FORCE_Y,0) = -9.810000; -NODES[2084](BODY_FORCE_Z,0) = 0.000000; -NODES[2085](BODY_FORCE_X,0) = 0.000000; -NODES[2085](BODY_FORCE_Y,0) = -9.810000; -NODES[2085](BODY_FORCE_Z,0) = 0.000000; -NODES[2086](BODY_FORCE_X,0) = 0.000000; -NODES[2086](BODY_FORCE_Y,0) = -9.810000; -NODES[2086](BODY_FORCE_Z,0) = 0.000000; -NODES[2087](BODY_FORCE_X,0) = 0.000000; -NODES[2087](BODY_FORCE_Y,0) = -9.810000; -NODES[2087](BODY_FORCE_Z,0) = 0.000000; -NODES[2088](BODY_FORCE_X,0) = 0.000000; -NODES[2088](BODY_FORCE_Y,0) = -9.810000; -NODES[2088](BODY_FORCE_Z,0) = 0.000000; -NODES[2089](BODY_FORCE_X,0) = 0.000000; -NODES[2089](BODY_FORCE_Y,0) = -9.810000; -NODES[2089](BODY_FORCE_Z,0) = 0.000000; -NODES[2090](BODY_FORCE_X,0) = 0.000000; -NODES[2090](BODY_FORCE_Y,0) = -9.810000; -NODES[2090](BODY_FORCE_Z,0) = 0.000000; -NODES[2091](BODY_FORCE_X,0) = 0.000000; -NODES[2091](BODY_FORCE_Y,0) = -9.810000; -NODES[2091](BODY_FORCE_Z,0) = 0.000000; -NODES[2092](BODY_FORCE_X,0) = 0.000000; -NODES[2092](BODY_FORCE_Y,0) = -9.810000; -NODES[2092](BODY_FORCE_Z,0) = 0.000000; -NODES[2093](BODY_FORCE_X,0) = 0.000000; -NODES[2093](BODY_FORCE_Y,0) = -9.810000; -NODES[2093](BODY_FORCE_Z,0) = 0.000000; -NODES[2094](BODY_FORCE_X,0) = 0.000000; -NODES[2094](BODY_FORCE_Y,0) = -9.810000; -NODES[2094](BODY_FORCE_Z,0) = 0.000000; -NODES[2095](BODY_FORCE_X,0) = 0.000000; -NODES[2095](BODY_FORCE_Y,0) = -9.810000; -NODES[2095](BODY_FORCE_Z,0) = 0.000000; -NODES[2096](BODY_FORCE_X,0) = 0.000000; -NODES[2096](BODY_FORCE_Y,0) = -9.810000; -NODES[2096](BODY_FORCE_Z,0) = 0.000000; -NODES[2097](BODY_FORCE_X,0) = 0.000000; -NODES[2097](BODY_FORCE_Y,0) = -9.810000; -NODES[2097](BODY_FORCE_Z,0) = 0.000000; -NODES[2098](BODY_FORCE_X,0) = 0.000000; -NODES[2098](BODY_FORCE_Y,0) = -9.810000; -NODES[2098](BODY_FORCE_Z,0) = 0.000000; -NODES[2099](BODY_FORCE_X,0) = 0.000000; -NODES[2099](BODY_FORCE_Y,0) = -9.810000; -NODES[2099](BODY_FORCE_Z,0) = 0.000000; -NODES[2100](BODY_FORCE_X,0) = 0.000000; -NODES[2100](BODY_FORCE_Y,0) = -9.810000; -NODES[2100](BODY_FORCE_Z,0) = 0.000000; -NODES[2101](BODY_FORCE_X,0) = 0.000000; -NODES[2101](BODY_FORCE_Y,0) = -9.810000; -NODES[2101](BODY_FORCE_Z,0) = 0.000000; -NODES[2102](BODY_FORCE_X,0) = 0.000000; -NODES[2102](BODY_FORCE_Y,0) = -9.810000; -NODES[2102](BODY_FORCE_Z,0) = 0.000000; -NODES[2103](BODY_FORCE_X,0) = 0.000000; -NODES[2103](BODY_FORCE_Y,0) = -9.810000; -NODES[2103](BODY_FORCE_Z,0) = 0.000000; -NODES[2104](BODY_FORCE_X,0) = 0.000000; -NODES[2104](BODY_FORCE_Y,0) = -9.810000; -NODES[2104](BODY_FORCE_Z,0) = 0.000000; -NODES[2105](BODY_FORCE_X,0) = 0.000000; -NODES[2105](BODY_FORCE_Y,0) = -9.810000; -NODES[2105](BODY_FORCE_Z,0) = 0.000000; -NODES[2106](BODY_FORCE_X,0) = 0.000000; -NODES[2106](BODY_FORCE_Y,0) = -9.810000; -NODES[2106](BODY_FORCE_Z,0) = 0.000000; -NODES[2107](BODY_FORCE_X,0) = 0.000000; -NODES[2107](BODY_FORCE_Y,0) = -9.810000; -NODES[2107](BODY_FORCE_Z,0) = 0.000000; -NODES[2108](BODY_FORCE_X,0) = 0.000000; -NODES[2108](BODY_FORCE_Y,0) = -9.810000; -NODES[2108](BODY_FORCE_Z,0) = 0.000000; -NODES[2109](BODY_FORCE_X,0) = 0.000000; -NODES[2109](BODY_FORCE_Y,0) = -9.810000; -NODES[2109](BODY_FORCE_Z,0) = 0.000000; -NODES[2111](BODY_FORCE_X,0) = 0.000000; -NODES[2111](BODY_FORCE_Y,0) = -9.810000; -NODES[2111](BODY_FORCE_Z,0) = 0.000000; -NODES[2112](BODY_FORCE_X,0) = 0.000000; -NODES[2112](BODY_FORCE_Y,0) = -9.810000; -NODES[2112](BODY_FORCE_Z,0) = 0.000000; -NODES[2113](BODY_FORCE_X,0) = 0.000000; -NODES[2113](BODY_FORCE_Y,0) = -9.810000; -NODES[2113](BODY_FORCE_Z,0) = 0.000000; -NODES[2114](BODY_FORCE_X,0) = 0.000000; -NODES[2114](BODY_FORCE_Y,0) = -9.810000; -NODES[2114](BODY_FORCE_Z,0) = 0.000000; -NODES[2115](BODY_FORCE_X,0) = 0.000000; -NODES[2115](BODY_FORCE_Y,0) = -9.810000; -NODES[2115](BODY_FORCE_Z,0) = 0.000000; -NODES[2116](BODY_FORCE_X,0) = 0.000000; -NODES[2116](BODY_FORCE_Y,0) = -9.810000; -NODES[2116](BODY_FORCE_Z,0) = 0.000000; -NODES[2117](BODY_FORCE_X,0) = 0.000000; -NODES[2117](BODY_FORCE_Y,0) = -9.810000; -NODES[2117](BODY_FORCE_Z,0) = 0.000000; -NODES[2118](BODY_FORCE_X,0) = 0.000000; -NODES[2118](BODY_FORCE_Y,0) = -9.810000; -NODES[2118](BODY_FORCE_Z,0) = 0.000000; -NODES[2119](BODY_FORCE_X,0) = 0.000000; -NODES[2119](BODY_FORCE_Y,0) = -9.810000; -NODES[2119](BODY_FORCE_Z,0) = 0.000000; -NODES[2120](BODY_FORCE_X,0) = 0.000000; -NODES[2120](BODY_FORCE_Y,0) = -9.810000; -NODES[2120](BODY_FORCE_Z,0) = 0.000000; -NODES[2121](BODY_FORCE_X,0) = 0.000000; -NODES[2121](BODY_FORCE_Y,0) = -9.810000; -NODES[2121](BODY_FORCE_Z,0) = 0.000000; -NODES[2122](BODY_FORCE_X,0) = 0.000000; -NODES[2122](BODY_FORCE_Y,0) = -9.810000; -NODES[2122](BODY_FORCE_Z,0) = 0.000000; -NODES[2123](BODY_FORCE_X,0) = 0.000000; -NODES[2123](BODY_FORCE_Y,0) = -9.810000; -NODES[2123](BODY_FORCE_Z,0) = 0.000000; -NODES[2124](BODY_FORCE_X,0) = 0.000000; -NODES[2124](BODY_FORCE_Y,0) = -9.810000; -NODES[2124](BODY_FORCE_Z,0) = 0.000000; -NODES[2125](BODY_FORCE_X,0) = 0.000000; -NODES[2125](BODY_FORCE_Y,0) = -9.810000; -NODES[2125](BODY_FORCE_Z,0) = 0.000000; -NODES[2126](BODY_FORCE_X,0) = 0.000000; -NODES[2126](BODY_FORCE_Y,0) = -9.810000; -NODES[2126](BODY_FORCE_Z,0) = 0.000000; -NODES[2127](BODY_FORCE_X,0) = 0.000000; -NODES[2127](BODY_FORCE_Y,0) = -9.810000; -NODES[2127](BODY_FORCE_Z,0) = 0.000000; -NODES[2128](BODY_FORCE_X,0) = 0.000000; -NODES[2128](BODY_FORCE_Y,0) = -9.810000; -NODES[2128](BODY_FORCE_Z,0) = 0.000000; -NODES[2129](BODY_FORCE_X,0) = 0.000000; -NODES[2129](BODY_FORCE_Y,0) = -9.810000; -NODES[2129](BODY_FORCE_Z,0) = 0.000000; -NODES[2130](BODY_FORCE_X,0) = 0.000000; -NODES[2130](BODY_FORCE_Y,0) = -9.810000; -NODES[2130](BODY_FORCE_Z,0) = 0.000000; -NODES[2131](BODY_FORCE_X,0) = 0.000000; -NODES[2131](BODY_FORCE_Y,0) = -9.810000; -NODES[2131](BODY_FORCE_Z,0) = 0.000000; -NODES[2132](BODY_FORCE_X,0) = 0.000000; -NODES[2132](BODY_FORCE_Y,0) = -9.810000; -NODES[2132](BODY_FORCE_Z,0) = 0.000000; -NODES[2133](BODY_FORCE_X,0) = 0.000000; -NODES[2133](BODY_FORCE_Y,0) = -9.810000; -NODES[2133](BODY_FORCE_Z,0) = 0.000000; -NODES[2134](BODY_FORCE_X,0) = 0.000000; -NODES[2134](BODY_FORCE_Y,0) = -9.810000; -NODES[2134](BODY_FORCE_Z,0) = 0.000000; -NODES[2135](BODY_FORCE_X,0) = 0.000000; -NODES[2135](BODY_FORCE_Y,0) = -9.810000; -NODES[2135](BODY_FORCE_Z,0) = 0.000000; -NODES[2136](BODY_FORCE_X,0) = 0.000000; -NODES[2136](BODY_FORCE_Y,0) = -9.810000; -NODES[2136](BODY_FORCE_Z,0) = 0.000000; -NODES[2137](BODY_FORCE_X,0) = 0.000000; -NODES[2137](BODY_FORCE_Y,0) = -9.810000; -NODES[2137](BODY_FORCE_Z,0) = 0.000000; -NODES[2138](BODY_FORCE_X,0) = 0.000000; -NODES[2138](BODY_FORCE_Y,0) = -9.810000; -NODES[2138](BODY_FORCE_Z,0) = 0.000000; -NODES[2139](BODY_FORCE_X,0) = 0.000000; -NODES[2139](BODY_FORCE_Y,0) = -9.810000; -NODES[2139](BODY_FORCE_Z,0) = 0.000000; -NODES[2140](BODY_FORCE_X,0) = 0.000000; -NODES[2140](BODY_FORCE_Y,0) = -9.810000; -NODES[2140](BODY_FORCE_Z,0) = 0.000000; -NODES[2141](BODY_FORCE_X,0) = 0.000000; -NODES[2141](BODY_FORCE_Y,0) = -9.810000; -NODES[2141](BODY_FORCE_Z,0) = 0.000000; -NODES[2142](BODY_FORCE_X,0) = 0.000000; -NODES[2142](BODY_FORCE_Y,0) = -9.810000; -NODES[2142](BODY_FORCE_Z,0) = 0.000000; -NODES[2144](BODY_FORCE_X,0) = 0.000000; -NODES[2144](BODY_FORCE_Y,0) = -9.810000; -NODES[2144](BODY_FORCE_Z,0) = 0.000000; -NODES[2145](BODY_FORCE_X,0) = 0.000000; -NODES[2145](BODY_FORCE_Y,0) = -9.810000; -NODES[2145](BODY_FORCE_Z,0) = 0.000000; -NODES[2146](BODY_FORCE_X,0) = 0.000000; -NODES[2146](BODY_FORCE_Y,0) = -9.810000; -NODES[2146](BODY_FORCE_Z,0) = 0.000000; -NODES[2147](BODY_FORCE_X,0) = 0.000000; -NODES[2147](BODY_FORCE_Y,0) = -9.810000; -NODES[2147](BODY_FORCE_Z,0) = 0.000000; -NODES[2148](BODY_FORCE_X,0) = 0.000000; -NODES[2148](BODY_FORCE_Y,0) = -9.810000; -NODES[2148](BODY_FORCE_Z,0) = 0.000000; -NODES[2149](BODY_FORCE_X,0) = 0.000000; -NODES[2149](BODY_FORCE_Y,0) = -9.810000; -NODES[2149](BODY_FORCE_Z,0) = 0.000000; -NODES[2150](BODY_FORCE_X,0) = 0.000000; -NODES[2150](BODY_FORCE_Y,0) = -9.810000; -NODES[2150](BODY_FORCE_Z,0) = 0.000000; -NODES[2151](BODY_FORCE_X,0) = 0.000000; -NODES[2151](BODY_FORCE_Y,0) = -9.810000; -NODES[2151](BODY_FORCE_Z,0) = 0.000000; -NODES[2152](BODY_FORCE_X,0) = 0.000000; -NODES[2152](BODY_FORCE_Y,0) = -9.810000; -NODES[2152](BODY_FORCE_Z,0) = 0.000000; -NODES[2153](BODY_FORCE_X,0) = 0.000000; -NODES[2153](BODY_FORCE_Y,0) = -9.810000; -NODES[2153](BODY_FORCE_Z,0) = 0.000000; -NODES[2154](BODY_FORCE_X,0) = 0.000000; -NODES[2154](BODY_FORCE_Y,0) = -9.810000; -NODES[2154](BODY_FORCE_Z,0) = 0.000000; -NODES[2155](BODY_FORCE_X,0) = 0.000000; -NODES[2155](BODY_FORCE_Y,0) = -9.810000; -NODES[2155](BODY_FORCE_Z,0) = 0.000000; -NODES[2156](BODY_FORCE_X,0) = 0.000000; -NODES[2156](BODY_FORCE_Y,0) = -9.810000; -NODES[2156](BODY_FORCE_Z,0) = 0.000000; -NODES[2157](BODY_FORCE_X,0) = 0.000000; -NODES[2157](BODY_FORCE_Y,0) = -9.810000; -NODES[2157](BODY_FORCE_Z,0) = 0.000000; -NODES[2158](BODY_FORCE_X,0) = 0.000000; -NODES[2158](BODY_FORCE_Y,0) = -9.810000; -NODES[2158](BODY_FORCE_Z,0) = 0.000000; -NODES[2159](BODY_FORCE_X,0) = 0.000000; -NODES[2159](BODY_FORCE_Y,0) = -9.810000; -NODES[2159](BODY_FORCE_Z,0) = 0.000000; -NODES[2160](BODY_FORCE_X,0) = 0.000000; -NODES[2160](BODY_FORCE_Y,0) = -9.810000; -NODES[2160](BODY_FORCE_Z,0) = 0.000000; -NODES[2161](BODY_FORCE_X,0) = 0.000000; -NODES[2161](BODY_FORCE_Y,0) = -9.810000; -NODES[2161](BODY_FORCE_Z,0) = 0.000000; -NODES[2162](BODY_FORCE_X,0) = 0.000000; -NODES[2162](BODY_FORCE_Y,0) = -9.810000; -NODES[2162](BODY_FORCE_Z,0) = 0.000000; -NODES[2163](BODY_FORCE_X,0) = 0.000000; -NODES[2163](BODY_FORCE_Y,0) = -9.810000; -NODES[2163](BODY_FORCE_Z,0) = 0.000000; -NODES[2164](BODY_FORCE_X,0) = 0.000000; -NODES[2164](BODY_FORCE_Y,0) = -9.810000; -NODES[2164](BODY_FORCE_Z,0) = 0.000000; -NODES[2165](BODY_FORCE_X,0) = 0.000000; -NODES[2165](BODY_FORCE_Y,0) = -9.810000; -NODES[2165](BODY_FORCE_Z,0) = 0.000000; -NODES[2166](BODY_FORCE_X,0) = 0.000000; -NODES[2166](BODY_FORCE_Y,0) = -9.810000; -NODES[2166](BODY_FORCE_Z,0) = 0.000000; -NODES[2167](BODY_FORCE_X,0) = 0.000000; -NODES[2167](BODY_FORCE_Y,0) = -9.810000; -NODES[2167](BODY_FORCE_Z,0) = 0.000000; -NODES[2168](BODY_FORCE_X,0) = 0.000000; -NODES[2168](BODY_FORCE_Y,0) = -9.810000; -NODES[2168](BODY_FORCE_Z,0) = 0.000000; -NODES[2169](BODY_FORCE_X,0) = 0.000000; -NODES[2169](BODY_FORCE_Y,0) = -9.810000; -NODES[2169](BODY_FORCE_Z,0) = 0.000000; -NODES[2170](BODY_FORCE_X,0) = 0.000000; -NODES[2170](BODY_FORCE_Y,0) = -9.810000; -NODES[2170](BODY_FORCE_Z,0) = 0.000000; -NODES[2171](BODY_FORCE_X,0) = 0.000000; -NODES[2171](BODY_FORCE_Y,0) = -9.810000; -NODES[2171](BODY_FORCE_Z,0) = 0.000000; -NODES[2172](BODY_FORCE_X,0) = 0.000000; -NODES[2172](BODY_FORCE_Y,0) = -9.810000; -NODES[2172](BODY_FORCE_Z,0) = 0.000000; -NODES[2173](BODY_FORCE_X,0) = 0.000000; -NODES[2173](BODY_FORCE_Y,0) = -9.810000; -NODES[2173](BODY_FORCE_Z,0) = 0.000000; -NODES[2174](BODY_FORCE_X,0) = 0.000000; -NODES[2174](BODY_FORCE_Y,0) = -9.810000; -NODES[2174](BODY_FORCE_Z,0) = 0.000000; -NODES[2175](BODY_FORCE_X,0) = 0.000000; -NODES[2175](BODY_FORCE_Y,0) = -9.810000; -NODES[2175](BODY_FORCE_Z,0) = 0.000000; -NODES[2177](BODY_FORCE_X,0) = 0.000000; -NODES[2177](BODY_FORCE_Y,0) = -9.810000; -NODES[2177](BODY_FORCE_Z,0) = 0.000000; -NODES[2178](BODY_FORCE_X,0) = 0.000000; -NODES[2178](BODY_FORCE_Y,0) = -9.810000; -NODES[2178](BODY_FORCE_Z,0) = 0.000000; -NODES[2179](BODY_FORCE_X,0) = 0.000000; -NODES[2179](BODY_FORCE_Y,0) = -9.810000; -NODES[2179](BODY_FORCE_Z,0) = 0.000000; -NODES[2180](BODY_FORCE_X,0) = 0.000000; -NODES[2180](BODY_FORCE_Y,0) = -9.810000; -NODES[2180](BODY_FORCE_Z,0) = 0.000000; -NODES[2181](BODY_FORCE_X,0) = 0.000000; -NODES[2181](BODY_FORCE_Y,0) = -9.810000; -NODES[2181](BODY_FORCE_Z,0) = 0.000000; -NODES[2182](BODY_FORCE_X,0) = 0.000000; -NODES[2182](BODY_FORCE_Y,0) = -9.810000; -NODES[2182](BODY_FORCE_Z,0) = 0.000000; -NODES[2183](BODY_FORCE_X,0) = 0.000000; -NODES[2183](BODY_FORCE_Y,0) = -9.810000; -NODES[2183](BODY_FORCE_Z,0) = 0.000000; -NODES[2184](BODY_FORCE_X,0) = 0.000000; -NODES[2184](BODY_FORCE_Y,0) = -9.810000; -NODES[2184](BODY_FORCE_Z,0) = 0.000000; -NODES[2185](BODY_FORCE_X,0) = 0.000000; -NODES[2185](BODY_FORCE_Y,0) = -9.810000; -NODES[2185](BODY_FORCE_Z,0) = 0.000000; -NODES[2186](BODY_FORCE_X,0) = 0.000000; -NODES[2186](BODY_FORCE_Y,0) = -9.810000; -NODES[2186](BODY_FORCE_Z,0) = 0.000000; -NODES[2187](BODY_FORCE_X,0) = 0.000000; -NODES[2187](BODY_FORCE_Y,0) = -9.810000; -NODES[2187](BODY_FORCE_Z,0) = 0.000000; -NODES[2188](BODY_FORCE_X,0) = 0.000000; -NODES[2188](BODY_FORCE_Y,0) = -9.810000; -NODES[2188](BODY_FORCE_Z,0) = 0.000000; -NODES[2189](BODY_FORCE_X,0) = 0.000000; -NODES[2189](BODY_FORCE_Y,0) = -9.810000; -NODES[2189](BODY_FORCE_Z,0) = 0.000000; -NODES[2190](BODY_FORCE_X,0) = 0.000000; -NODES[2190](BODY_FORCE_Y,0) = -9.810000; -NODES[2190](BODY_FORCE_Z,0) = 0.000000; -NODES[2191](BODY_FORCE_X,0) = 0.000000; -NODES[2191](BODY_FORCE_Y,0) = -9.810000; -NODES[2191](BODY_FORCE_Z,0) = 0.000000; -NODES[2192](BODY_FORCE_X,0) = 0.000000; -NODES[2192](BODY_FORCE_Y,0) = -9.810000; -NODES[2192](BODY_FORCE_Z,0) = 0.000000; -NODES[2193](BODY_FORCE_X,0) = 0.000000; -NODES[2193](BODY_FORCE_Y,0) = -9.810000; -NODES[2193](BODY_FORCE_Z,0) = 0.000000; -NODES[2194](BODY_FORCE_X,0) = 0.000000; -NODES[2194](BODY_FORCE_Y,0) = -9.810000; -NODES[2194](BODY_FORCE_Z,0) = 0.000000; -NODES[2195](BODY_FORCE_X,0) = 0.000000; -NODES[2195](BODY_FORCE_Y,0) = -9.810000; -NODES[2195](BODY_FORCE_Z,0) = 0.000000; -NODES[2196](BODY_FORCE_X,0) = 0.000000; -NODES[2196](BODY_FORCE_Y,0) = -9.810000; -NODES[2196](BODY_FORCE_Z,0) = 0.000000; -NODES[2197](BODY_FORCE_X,0) = 0.000000; -NODES[2197](BODY_FORCE_Y,0) = -9.810000; -NODES[2197](BODY_FORCE_Z,0) = 0.000000; -NODES[2198](BODY_FORCE_X,0) = 0.000000; -NODES[2198](BODY_FORCE_Y,0) = -9.810000; -NODES[2198](BODY_FORCE_Z,0) = 0.000000; -NODES[2199](BODY_FORCE_X,0) = 0.000000; -NODES[2199](BODY_FORCE_Y,0) = -9.810000; -NODES[2199](BODY_FORCE_Z,0) = 0.000000; -NODES[2200](BODY_FORCE_X,0) = 0.000000; -NODES[2200](BODY_FORCE_Y,0) = -9.810000; -NODES[2200](BODY_FORCE_Z,0) = 0.000000; -NODES[2201](BODY_FORCE_X,0) = 0.000000; -NODES[2201](BODY_FORCE_Y,0) = -9.810000; -NODES[2201](BODY_FORCE_Z,0) = 0.000000; -NODES[2202](BODY_FORCE_X,0) = 0.000000; -NODES[2202](BODY_FORCE_Y,0) = -9.810000; -NODES[2202](BODY_FORCE_Z,0) = 0.000000; -NODES[2203](BODY_FORCE_X,0) = 0.000000; -NODES[2203](BODY_FORCE_Y,0) = -9.810000; -NODES[2203](BODY_FORCE_Z,0) = 0.000000; -NODES[2204](BODY_FORCE_X,0) = 0.000000; -NODES[2204](BODY_FORCE_Y,0) = -9.810000; -NODES[2204](BODY_FORCE_Z,0) = 0.000000; -NODES[2205](BODY_FORCE_X,0) = 0.000000; -NODES[2205](BODY_FORCE_Y,0) = -9.810000; -NODES[2205](BODY_FORCE_Z,0) = 0.000000; -NODES[2206](BODY_FORCE_X,0) = 0.000000; -NODES[2206](BODY_FORCE_Y,0) = -9.810000; -NODES[2206](BODY_FORCE_Z,0) = 0.000000; -NODES[2207](BODY_FORCE_X,0) = 0.000000; -NODES[2207](BODY_FORCE_Y,0) = -9.810000; -NODES[2207](BODY_FORCE_Z,0) = 0.000000; -NODES[2209](BODY_FORCE_X,0) = 0.000000; -NODES[2209](BODY_FORCE_Y,0) = -9.810000; -NODES[2209](BODY_FORCE_Z,0) = 0.000000; -NODES[2210](BODY_FORCE_X,0) = 0.000000; -NODES[2210](BODY_FORCE_Y,0) = -9.810000; -NODES[2210](BODY_FORCE_Z,0) = 0.000000; -NODES[2211](BODY_FORCE_X,0) = 0.000000; -NODES[2211](BODY_FORCE_Y,0) = -9.810000; -NODES[2211](BODY_FORCE_Z,0) = 0.000000; -NODES[2212](BODY_FORCE_X,0) = 0.000000; -NODES[2212](BODY_FORCE_Y,0) = -9.810000; -NODES[2212](BODY_FORCE_Z,0) = 0.000000; -NODES[2213](BODY_FORCE_X,0) = 0.000000; -NODES[2213](BODY_FORCE_Y,0) = -9.810000; -NODES[2213](BODY_FORCE_Z,0) = 0.000000; -NODES[2214](BODY_FORCE_X,0) = 0.000000; -NODES[2214](BODY_FORCE_Y,0) = -9.810000; -NODES[2214](BODY_FORCE_Z,0) = 0.000000; -NODES[2215](BODY_FORCE_X,0) = 0.000000; -NODES[2215](BODY_FORCE_Y,0) = -9.810000; -NODES[2215](BODY_FORCE_Z,0) = 0.000000; -NODES[2216](BODY_FORCE_X,0) = 0.000000; -NODES[2216](BODY_FORCE_Y,0) = -9.810000; -NODES[2216](BODY_FORCE_Z,0) = 0.000000; -NODES[2217](BODY_FORCE_X,0) = 0.000000; -NODES[2217](BODY_FORCE_Y,0) = -9.810000; -NODES[2217](BODY_FORCE_Z,0) = 0.000000; -NODES[2218](BODY_FORCE_X,0) = 0.000000; -NODES[2218](BODY_FORCE_Y,0) = -9.810000; -NODES[2218](BODY_FORCE_Z,0) = 0.000000; -NODES[2219](BODY_FORCE_X,0) = 0.000000; -NODES[2219](BODY_FORCE_Y,0) = -9.810000; -NODES[2219](BODY_FORCE_Z,0) = 0.000000; -NODES[2220](BODY_FORCE_X,0) = 0.000000; -NODES[2220](BODY_FORCE_Y,0) = -9.810000; -NODES[2220](BODY_FORCE_Z,0) = 0.000000; -NODES[2221](BODY_FORCE_X,0) = 0.000000; -NODES[2221](BODY_FORCE_Y,0) = -9.810000; -NODES[2221](BODY_FORCE_Z,0) = 0.000000; -NODES[2222](BODY_FORCE_X,0) = 0.000000; -NODES[2222](BODY_FORCE_Y,0) = -9.810000; -NODES[2222](BODY_FORCE_Z,0) = 0.000000; -NODES[2223](BODY_FORCE_X,0) = 0.000000; -NODES[2223](BODY_FORCE_Y,0) = -9.810000; -NODES[2223](BODY_FORCE_Z,0) = 0.000000; -NODES[2224](BODY_FORCE_X,0) = 0.000000; -NODES[2224](BODY_FORCE_Y,0) = -9.810000; -NODES[2224](BODY_FORCE_Z,0) = 0.000000; -NODES[2225](BODY_FORCE_X,0) = 0.000000; -NODES[2225](BODY_FORCE_Y,0) = -9.810000; -NODES[2225](BODY_FORCE_Z,0) = 0.000000; -NODES[2226](BODY_FORCE_X,0) = 0.000000; -NODES[2226](BODY_FORCE_Y,0) = -9.810000; -NODES[2226](BODY_FORCE_Z,0) = 0.000000; -NODES[2227](BODY_FORCE_X,0) = 0.000000; -NODES[2227](BODY_FORCE_Y,0) = -9.810000; -NODES[2227](BODY_FORCE_Z,0) = 0.000000; -NODES[2228](BODY_FORCE_X,0) = 0.000000; -NODES[2228](BODY_FORCE_Y,0) = -9.810000; -NODES[2228](BODY_FORCE_Z,0) = 0.000000; -NODES[2229](BODY_FORCE_X,0) = 0.000000; -NODES[2229](BODY_FORCE_Y,0) = -9.810000; -NODES[2229](BODY_FORCE_Z,0) = 0.000000; -NODES[2230](BODY_FORCE_X,0) = 0.000000; -NODES[2230](BODY_FORCE_Y,0) = -9.810000; -NODES[2230](BODY_FORCE_Z,0) = 0.000000; -NODES[2231](BODY_FORCE_X,0) = 0.000000; -NODES[2231](BODY_FORCE_Y,0) = -9.810000; -NODES[2231](BODY_FORCE_Z,0) = 0.000000; -NODES[2232](BODY_FORCE_X,0) = 0.000000; -NODES[2232](BODY_FORCE_Y,0) = -9.810000; -NODES[2232](BODY_FORCE_Z,0) = 0.000000; -NODES[2233](BODY_FORCE_X,0) = 0.000000; -NODES[2233](BODY_FORCE_Y,0) = -9.810000; -NODES[2233](BODY_FORCE_Z,0) = 0.000000; -NODES[2234](BODY_FORCE_X,0) = 0.000000; -NODES[2234](BODY_FORCE_Y,0) = -9.810000; -NODES[2234](BODY_FORCE_Z,0) = 0.000000; -NODES[2235](BODY_FORCE_X,0) = 0.000000; -NODES[2235](BODY_FORCE_Y,0) = -9.810000; -NODES[2235](BODY_FORCE_Z,0) = 0.000000; -NODES[2236](BODY_FORCE_X,0) = 0.000000; -NODES[2236](BODY_FORCE_Y,0) = -9.810000; -NODES[2236](BODY_FORCE_Z,0) = 0.000000; -NODES[2237](BODY_FORCE_X,0) = 0.000000; -NODES[2237](BODY_FORCE_Y,0) = -9.810000; -NODES[2237](BODY_FORCE_Z,0) = 0.000000; -NODES[2238](BODY_FORCE_X,0) = 0.000000; -NODES[2238](BODY_FORCE_Y,0) = -9.810000; -NODES[2238](BODY_FORCE_Z,0) = 0.000000; -NODES[2239](BODY_FORCE_X,0) = 0.000000; -NODES[2239](BODY_FORCE_Y,0) = -9.810000; -NODES[2239](BODY_FORCE_Z,0) = 0.000000; -NODES[2241](BODY_FORCE_X,0) = 0.000000; -NODES[2241](BODY_FORCE_Y,0) = -9.810000; -NODES[2241](BODY_FORCE_Z,0) = 0.000000; -NODES[2242](BODY_FORCE_X,0) = 0.000000; -NODES[2242](BODY_FORCE_Y,0) = -9.810000; -NODES[2242](BODY_FORCE_Z,0) = 0.000000; -NODES[2243](BODY_FORCE_X,0) = 0.000000; -NODES[2243](BODY_FORCE_Y,0) = -9.810000; -NODES[2243](BODY_FORCE_Z,0) = 0.000000; -NODES[2244](BODY_FORCE_X,0) = 0.000000; -NODES[2244](BODY_FORCE_Y,0) = -9.810000; -NODES[2244](BODY_FORCE_Z,0) = 0.000000; -NODES[2245](BODY_FORCE_X,0) = 0.000000; -NODES[2245](BODY_FORCE_Y,0) = -9.810000; -NODES[2245](BODY_FORCE_Z,0) = 0.000000; -NODES[2246](BODY_FORCE_X,0) = 0.000000; -NODES[2246](BODY_FORCE_Y,0) = -9.810000; -NODES[2246](BODY_FORCE_Z,0) = 0.000000; -NODES[2247](BODY_FORCE_X,0) = 0.000000; -NODES[2247](BODY_FORCE_Y,0) = -9.810000; -NODES[2247](BODY_FORCE_Z,0) = 0.000000; -NODES[2248](BODY_FORCE_X,0) = 0.000000; -NODES[2248](BODY_FORCE_Y,0) = -9.810000; -NODES[2248](BODY_FORCE_Z,0) = 0.000000; -NODES[2249](BODY_FORCE_X,0) = 0.000000; -NODES[2249](BODY_FORCE_Y,0) = -9.810000; -NODES[2249](BODY_FORCE_Z,0) = 0.000000; -NODES[2250](BODY_FORCE_X,0) = 0.000000; -NODES[2250](BODY_FORCE_Y,0) = -9.810000; -NODES[2250](BODY_FORCE_Z,0) = 0.000000; -NODES[2251](BODY_FORCE_X,0) = 0.000000; -NODES[2251](BODY_FORCE_Y,0) = -9.810000; -NODES[2251](BODY_FORCE_Z,0) = 0.000000; -NODES[2252](BODY_FORCE_X,0) = 0.000000; -NODES[2252](BODY_FORCE_Y,0) = -9.810000; -NODES[2252](BODY_FORCE_Z,0) = 0.000000; -NODES[2253](BODY_FORCE_X,0) = 0.000000; -NODES[2253](BODY_FORCE_Y,0) = -9.810000; -NODES[2253](BODY_FORCE_Z,0) = 0.000000; -NODES[2254](BODY_FORCE_X,0) = 0.000000; -NODES[2254](BODY_FORCE_Y,0) = -9.810000; -NODES[2254](BODY_FORCE_Z,0) = 0.000000; -NODES[2255](BODY_FORCE_X,0) = 0.000000; -NODES[2255](BODY_FORCE_Y,0) = -9.810000; -NODES[2255](BODY_FORCE_Z,0) = 0.000000; -NODES[2256](BODY_FORCE_X,0) = 0.000000; -NODES[2256](BODY_FORCE_Y,0) = -9.810000; -NODES[2256](BODY_FORCE_Z,0) = 0.000000; -NODES[2257](BODY_FORCE_X,0) = 0.000000; -NODES[2257](BODY_FORCE_Y,0) = -9.810000; -NODES[2257](BODY_FORCE_Z,0) = 0.000000; -NODES[2258](BODY_FORCE_X,0) = 0.000000; -NODES[2258](BODY_FORCE_Y,0) = -9.810000; -NODES[2258](BODY_FORCE_Z,0) = 0.000000; -NODES[2259](BODY_FORCE_X,0) = 0.000000; -NODES[2259](BODY_FORCE_Y,0) = -9.810000; -NODES[2259](BODY_FORCE_Z,0) = 0.000000; -NODES[2260](BODY_FORCE_X,0) = 0.000000; -NODES[2260](BODY_FORCE_Y,0) = -9.810000; -NODES[2260](BODY_FORCE_Z,0) = 0.000000; -NODES[2261](BODY_FORCE_X,0) = 0.000000; -NODES[2261](BODY_FORCE_Y,0) = -9.810000; -NODES[2261](BODY_FORCE_Z,0) = 0.000000; -NODES[2262](BODY_FORCE_X,0) = 0.000000; -NODES[2262](BODY_FORCE_Y,0) = -9.810000; -NODES[2262](BODY_FORCE_Z,0) = 0.000000; -NODES[2263](BODY_FORCE_X,0) = 0.000000; -NODES[2263](BODY_FORCE_Y,0) = -9.810000; -NODES[2263](BODY_FORCE_Z,0) = 0.000000; -NODES[2264](BODY_FORCE_X,0) = 0.000000; -NODES[2264](BODY_FORCE_Y,0) = -9.810000; -NODES[2264](BODY_FORCE_Z,0) = 0.000000; -NODES[2265](BODY_FORCE_X,0) = 0.000000; -NODES[2265](BODY_FORCE_Y,0) = -9.810000; -NODES[2265](BODY_FORCE_Z,0) = 0.000000; -NODES[2266](BODY_FORCE_X,0) = 0.000000; -NODES[2266](BODY_FORCE_Y,0) = -9.810000; -NODES[2266](BODY_FORCE_Z,0) = 0.000000; -NODES[2267](BODY_FORCE_X,0) = 0.000000; -NODES[2267](BODY_FORCE_Y,0) = -9.810000; -NODES[2267](BODY_FORCE_Z,0) = 0.000000; -NODES[2268](BODY_FORCE_X,0) = 0.000000; -NODES[2268](BODY_FORCE_Y,0) = -9.810000; -NODES[2268](BODY_FORCE_Z,0) = 0.000000; -NODES[2269](BODY_FORCE_X,0) = 0.000000; -NODES[2269](BODY_FORCE_Y,0) = -9.810000; -NODES[2269](BODY_FORCE_Z,0) = 0.000000; -NODES[2270](BODY_FORCE_X,0) = 0.000000; -NODES[2270](BODY_FORCE_Y,0) = -9.810000; -NODES[2270](BODY_FORCE_Z,0) = 0.000000; -NODES[2271](BODY_FORCE_X,0) = 0.000000; -NODES[2271](BODY_FORCE_Y,0) = -9.810000; -NODES[2271](BODY_FORCE_Z,0) = 0.000000; -NODES[2273](BODY_FORCE_X,0) = 0.000000; -NODES[2273](BODY_FORCE_Y,0) = -9.810000; -NODES[2273](BODY_FORCE_Z,0) = 0.000000; -NODES[2274](BODY_FORCE_X,0) = 0.000000; -NODES[2274](BODY_FORCE_Y,0) = -9.810000; -NODES[2274](BODY_FORCE_Z,0) = 0.000000; -NODES[2275](BODY_FORCE_X,0) = 0.000000; -NODES[2275](BODY_FORCE_Y,0) = -9.810000; -NODES[2275](BODY_FORCE_Z,0) = 0.000000; -NODES[2276](BODY_FORCE_X,0) = 0.000000; -NODES[2276](BODY_FORCE_Y,0) = -9.810000; -NODES[2276](BODY_FORCE_Z,0) = 0.000000; -NODES[2277](BODY_FORCE_X,0) = 0.000000; -NODES[2277](BODY_FORCE_Y,0) = -9.810000; -NODES[2277](BODY_FORCE_Z,0) = 0.000000; -NODES[2278](BODY_FORCE_X,0) = 0.000000; -NODES[2278](BODY_FORCE_Y,0) = -9.810000; -NODES[2278](BODY_FORCE_Z,0) = 0.000000; -NODES[2279](BODY_FORCE_X,0) = 0.000000; -NODES[2279](BODY_FORCE_Y,0) = -9.810000; -NODES[2279](BODY_FORCE_Z,0) = 0.000000; -NODES[2280](BODY_FORCE_X,0) = 0.000000; -NODES[2280](BODY_FORCE_Y,0) = -9.810000; -NODES[2280](BODY_FORCE_Z,0) = 0.000000; -NODES[2281](BODY_FORCE_X,0) = 0.000000; -NODES[2281](BODY_FORCE_Y,0) = -9.810000; -NODES[2281](BODY_FORCE_Z,0) = 0.000000; -NODES[2282](BODY_FORCE_X,0) = 0.000000; -NODES[2282](BODY_FORCE_Y,0) = -9.810000; -NODES[2282](BODY_FORCE_Z,0) = 0.000000; -NODES[2283](BODY_FORCE_X,0) = 0.000000; -NODES[2283](BODY_FORCE_Y,0) = -9.810000; -NODES[2283](BODY_FORCE_Z,0) = 0.000000; -NODES[2284](BODY_FORCE_X,0) = 0.000000; -NODES[2284](BODY_FORCE_Y,0) = -9.810000; -NODES[2284](BODY_FORCE_Z,0) = 0.000000; -NODES[2285](BODY_FORCE_X,0) = 0.000000; -NODES[2285](BODY_FORCE_Y,0) = -9.810000; -NODES[2285](BODY_FORCE_Z,0) = 0.000000; -NODES[2286](BODY_FORCE_X,0) = 0.000000; -NODES[2286](BODY_FORCE_Y,0) = -9.810000; -NODES[2286](BODY_FORCE_Z,0) = 0.000000; -NODES[2287](BODY_FORCE_X,0) = 0.000000; -NODES[2287](BODY_FORCE_Y,0) = -9.810000; -NODES[2287](BODY_FORCE_Z,0) = 0.000000; -NODES[2288](BODY_FORCE_X,0) = 0.000000; -NODES[2288](BODY_FORCE_Y,0) = -9.810000; -NODES[2288](BODY_FORCE_Z,0) = 0.000000; -NODES[2289](BODY_FORCE_X,0) = 0.000000; -NODES[2289](BODY_FORCE_Y,0) = -9.810000; -NODES[2289](BODY_FORCE_Z,0) = 0.000000; -NODES[2290](BODY_FORCE_X,0) = 0.000000; -NODES[2290](BODY_FORCE_Y,0) = -9.810000; -NODES[2290](BODY_FORCE_Z,0) = 0.000000; -NODES[2291](BODY_FORCE_X,0) = 0.000000; -NODES[2291](BODY_FORCE_Y,0) = -9.810000; -NODES[2291](BODY_FORCE_Z,0) = 0.000000; -NODES[2292](BODY_FORCE_X,0) = 0.000000; -NODES[2292](BODY_FORCE_Y,0) = -9.810000; -NODES[2292](BODY_FORCE_Z,0) = 0.000000; -NODES[2293](BODY_FORCE_X,0) = 0.000000; -NODES[2293](BODY_FORCE_Y,0) = -9.810000; -NODES[2293](BODY_FORCE_Z,0) = 0.000000; -NODES[2294](BODY_FORCE_X,0) = 0.000000; -NODES[2294](BODY_FORCE_Y,0) = -9.810000; -NODES[2294](BODY_FORCE_Z,0) = 0.000000; -NODES[2295](BODY_FORCE_X,0) = 0.000000; -NODES[2295](BODY_FORCE_Y,0) = -9.810000; -NODES[2295](BODY_FORCE_Z,0) = 0.000000; -NODES[2296](BODY_FORCE_X,0) = 0.000000; -NODES[2296](BODY_FORCE_Y,0) = -9.810000; -NODES[2296](BODY_FORCE_Z,0) = 0.000000; -NODES[2297](BODY_FORCE_X,0) = 0.000000; -NODES[2297](BODY_FORCE_Y,0) = -9.810000; -NODES[2297](BODY_FORCE_Z,0) = 0.000000; -NODES[2298](BODY_FORCE_X,0) = 0.000000; -NODES[2298](BODY_FORCE_Y,0) = -9.810000; -NODES[2298](BODY_FORCE_Z,0) = 0.000000; -NODES[2299](BODY_FORCE_X,0) = 0.000000; -NODES[2299](BODY_FORCE_Y,0) = -9.810000; -NODES[2299](BODY_FORCE_Z,0) = 0.000000; -NODES[2300](BODY_FORCE_X,0) = 0.000000; -NODES[2300](BODY_FORCE_Y,0) = -9.810000; -NODES[2300](BODY_FORCE_Z,0) = 0.000000; -NODES[2301](BODY_FORCE_X,0) = 0.000000; -NODES[2301](BODY_FORCE_Y,0) = -9.810000; -NODES[2301](BODY_FORCE_Z,0) = 0.000000; -NODES[2302](BODY_FORCE_X,0) = 0.000000; -NODES[2302](BODY_FORCE_Y,0) = -9.810000; -NODES[2302](BODY_FORCE_Z,0) = 0.000000; -NODES[2304](BODY_FORCE_X,0) = 0.000000; -NODES[2304](BODY_FORCE_Y,0) = -9.810000; -NODES[2304](BODY_FORCE_Z,0) = 0.000000; -NODES[2305](BODY_FORCE_X,0) = 0.000000; -NODES[2305](BODY_FORCE_Y,0) = -9.810000; -NODES[2305](BODY_FORCE_Z,0) = 0.000000; -NODES[2306](BODY_FORCE_X,0) = 0.000000; -NODES[2306](BODY_FORCE_Y,0) = -9.810000; -NODES[2306](BODY_FORCE_Z,0) = 0.000000; -NODES[2307](BODY_FORCE_X,0) = 0.000000; -NODES[2307](BODY_FORCE_Y,0) = -9.810000; -NODES[2307](BODY_FORCE_Z,0) = 0.000000; -NODES[2308](BODY_FORCE_X,0) = 0.000000; -NODES[2308](BODY_FORCE_Y,0) = -9.810000; -NODES[2308](BODY_FORCE_Z,0) = 0.000000; -NODES[2309](BODY_FORCE_X,0) = 0.000000; -NODES[2309](BODY_FORCE_Y,0) = -9.810000; -NODES[2309](BODY_FORCE_Z,0) = 0.000000; -NODES[2310](BODY_FORCE_X,0) = 0.000000; -NODES[2310](BODY_FORCE_Y,0) = -9.810000; -NODES[2310](BODY_FORCE_Z,0) = 0.000000; -NODES[2311](BODY_FORCE_X,0) = 0.000000; -NODES[2311](BODY_FORCE_Y,0) = -9.810000; -NODES[2311](BODY_FORCE_Z,0) = 0.000000; -NODES[2312](BODY_FORCE_X,0) = 0.000000; -NODES[2312](BODY_FORCE_Y,0) = -9.810000; -NODES[2312](BODY_FORCE_Z,0) = 0.000000; -NODES[2313](BODY_FORCE_X,0) = 0.000000; -NODES[2313](BODY_FORCE_Y,0) = -9.810000; -NODES[2313](BODY_FORCE_Z,0) = 0.000000; -NODES[2314](BODY_FORCE_X,0) = 0.000000; -NODES[2314](BODY_FORCE_Y,0) = -9.810000; -NODES[2314](BODY_FORCE_Z,0) = 0.000000; -NODES[2315](BODY_FORCE_X,0) = 0.000000; -NODES[2315](BODY_FORCE_Y,0) = -9.810000; -NODES[2315](BODY_FORCE_Z,0) = 0.000000; -NODES[2316](BODY_FORCE_X,0) = 0.000000; -NODES[2316](BODY_FORCE_Y,0) = -9.810000; -NODES[2316](BODY_FORCE_Z,0) = 0.000000; -NODES[2317](BODY_FORCE_X,0) = 0.000000; -NODES[2317](BODY_FORCE_Y,0) = -9.810000; -NODES[2317](BODY_FORCE_Z,0) = 0.000000; -NODES[2318](BODY_FORCE_X,0) = 0.000000; -NODES[2318](BODY_FORCE_Y,0) = -9.810000; -NODES[2318](BODY_FORCE_Z,0) = 0.000000; -NODES[2319](BODY_FORCE_X,0) = 0.000000; -NODES[2319](BODY_FORCE_Y,0) = -9.810000; -NODES[2319](BODY_FORCE_Z,0) = 0.000000; -NODES[2320](BODY_FORCE_X,0) = 0.000000; -NODES[2320](BODY_FORCE_Y,0) = -9.810000; -NODES[2320](BODY_FORCE_Z,0) = 0.000000; -NODES[2321](BODY_FORCE_X,0) = 0.000000; -NODES[2321](BODY_FORCE_Y,0) = -9.810000; -NODES[2321](BODY_FORCE_Z,0) = 0.000000; -NODES[2322](BODY_FORCE_X,0) = 0.000000; -NODES[2322](BODY_FORCE_Y,0) = -9.810000; -NODES[2322](BODY_FORCE_Z,0) = 0.000000; -NODES[2323](BODY_FORCE_X,0) = 0.000000; -NODES[2323](BODY_FORCE_Y,0) = -9.810000; -NODES[2323](BODY_FORCE_Z,0) = 0.000000; -NODES[2324](BODY_FORCE_X,0) = 0.000000; -NODES[2324](BODY_FORCE_Y,0) = -9.810000; -NODES[2324](BODY_FORCE_Z,0) = 0.000000; -NODES[2325](BODY_FORCE_X,0) = 0.000000; -NODES[2325](BODY_FORCE_Y,0) = -9.810000; -NODES[2325](BODY_FORCE_Z,0) = 0.000000; -NODES[2326](BODY_FORCE_X,0) = 0.000000; -NODES[2326](BODY_FORCE_Y,0) = -9.810000; -NODES[2326](BODY_FORCE_Z,0) = 0.000000; -NODES[2327](BODY_FORCE_X,0) = 0.000000; -NODES[2327](BODY_FORCE_Y,0) = -9.810000; -NODES[2327](BODY_FORCE_Z,0) = 0.000000; -NODES[2328](BODY_FORCE_X,0) = 0.000000; -NODES[2328](BODY_FORCE_Y,0) = -9.810000; -NODES[2328](BODY_FORCE_Z,0) = 0.000000; -NODES[2329](BODY_FORCE_X,0) = 0.000000; -NODES[2329](BODY_FORCE_Y,0) = -9.810000; -NODES[2329](BODY_FORCE_Z,0) = 0.000000; -NODES[2330](BODY_FORCE_X,0) = 0.000000; -NODES[2330](BODY_FORCE_Y,0) = -9.810000; -NODES[2330](BODY_FORCE_Z,0) = 0.000000; -NODES[2331](BODY_FORCE_X,0) = 0.000000; -NODES[2331](BODY_FORCE_Y,0) = -9.810000; -NODES[2331](BODY_FORCE_Z,0) = 0.000000; -NODES[2332](BODY_FORCE_X,0) = 0.000000; -NODES[2332](BODY_FORCE_Y,0) = -9.810000; -NODES[2332](BODY_FORCE_Z,0) = 0.000000; -NODES[2333](BODY_FORCE_X,0) = 0.000000; -NODES[2333](BODY_FORCE_Y,0) = -9.810000; -NODES[2333](BODY_FORCE_Z,0) = 0.000000; -NODES[2334](BODY_FORCE_X,0) = 0.000000; -NODES[2334](BODY_FORCE_Y,0) = -9.810000; -NODES[2334](BODY_FORCE_Z,0) = 0.000000; -NODES[2335](BODY_FORCE_X,0) = 0.000000; -NODES[2335](BODY_FORCE_Y,0) = -9.810000; -NODES[2335](BODY_FORCE_Z,0) = 0.000000; -NODES[2337](BODY_FORCE_X,0) = 0.000000; -NODES[2337](BODY_FORCE_Y,0) = -9.810000; -NODES[2337](BODY_FORCE_Z,0) = 0.000000; -NODES[2338](BODY_FORCE_X,0) = 0.000000; -NODES[2338](BODY_FORCE_Y,0) = -9.810000; -NODES[2338](BODY_FORCE_Z,0) = 0.000000; -NODES[2339](BODY_FORCE_X,0) = 0.000000; -NODES[2339](BODY_FORCE_Y,0) = -9.810000; -NODES[2339](BODY_FORCE_Z,0) = 0.000000; -NODES[2340](BODY_FORCE_X,0) = 0.000000; -NODES[2340](BODY_FORCE_Y,0) = -9.810000; -NODES[2340](BODY_FORCE_Z,0) = 0.000000; -NODES[2341](BODY_FORCE_X,0) = 0.000000; -NODES[2341](BODY_FORCE_Y,0) = -9.810000; -NODES[2341](BODY_FORCE_Z,0) = 0.000000; -NODES[2342](BODY_FORCE_X,0) = 0.000000; -NODES[2342](BODY_FORCE_Y,0) = -9.810000; -NODES[2342](BODY_FORCE_Z,0) = 0.000000; -NODES[2343](BODY_FORCE_X,0) = 0.000000; -NODES[2343](BODY_FORCE_Y,0) = -9.810000; -NODES[2343](BODY_FORCE_Z,0) = 0.000000; -NODES[2344](BODY_FORCE_X,0) = 0.000000; -NODES[2344](BODY_FORCE_Y,0) = -9.810000; -NODES[2344](BODY_FORCE_Z,0) = 0.000000; -NODES[2345](BODY_FORCE_X,0) = 0.000000; -NODES[2345](BODY_FORCE_Y,0) = -9.810000; -NODES[2345](BODY_FORCE_Z,0) = 0.000000; -NODES[2346](BODY_FORCE_X,0) = 0.000000; -NODES[2346](BODY_FORCE_Y,0) = -9.810000; -NODES[2346](BODY_FORCE_Z,0) = 0.000000; -NODES[2347](BODY_FORCE_X,0) = 0.000000; -NODES[2347](BODY_FORCE_Y,0) = -9.810000; -NODES[2347](BODY_FORCE_Z,0) = 0.000000; -NODES[2348](BODY_FORCE_X,0) = 0.000000; -NODES[2348](BODY_FORCE_Y,0) = -9.810000; -NODES[2348](BODY_FORCE_Z,0) = 0.000000; -NODES[2349](BODY_FORCE_X,0) = 0.000000; -NODES[2349](BODY_FORCE_Y,0) = -9.810000; -NODES[2349](BODY_FORCE_Z,0) = 0.000000; -NODES[2350](BODY_FORCE_X,0) = 0.000000; -NODES[2350](BODY_FORCE_Y,0) = -9.810000; -NODES[2350](BODY_FORCE_Z,0) = 0.000000; -NODES[2351](BODY_FORCE_X,0) = 0.000000; -NODES[2351](BODY_FORCE_Y,0) = -9.810000; -NODES[2351](BODY_FORCE_Z,0) = 0.000000; -NODES[2352](BODY_FORCE_X,0) = 0.000000; -NODES[2352](BODY_FORCE_Y,0) = -9.810000; -NODES[2352](BODY_FORCE_Z,0) = 0.000000; -NODES[2353](BODY_FORCE_X,0) = 0.000000; -NODES[2353](BODY_FORCE_Y,0) = -9.810000; -NODES[2353](BODY_FORCE_Z,0) = 0.000000; -NODES[2354](BODY_FORCE_X,0) = 0.000000; -NODES[2354](BODY_FORCE_Y,0) = -9.810000; -NODES[2354](BODY_FORCE_Z,0) = 0.000000; -NODES[2355](BODY_FORCE_X,0) = 0.000000; -NODES[2355](BODY_FORCE_Y,0) = -9.810000; -NODES[2355](BODY_FORCE_Z,0) = 0.000000; -NODES[2356](BODY_FORCE_X,0) = 0.000000; -NODES[2356](BODY_FORCE_Y,0) = -9.810000; -NODES[2356](BODY_FORCE_Z,0) = 0.000000; -NODES[2357](BODY_FORCE_X,0) = 0.000000; -NODES[2357](BODY_FORCE_Y,0) = -9.810000; -NODES[2357](BODY_FORCE_Z,0) = 0.000000; -NODES[2358](BODY_FORCE_X,0) = 0.000000; -NODES[2358](BODY_FORCE_Y,0) = -9.810000; -NODES[2358](BODY_FORCE_Z,0) = 0.000000; -NODES[2359](BODY_FORCE_X,0) = 0.000000; -NODES[2359](BODY_FORCE_Y,0) = -9.810000; -NODES[2359](BODY_FORCE_Z,0) = 0.000000; -NODES[2360](BODY_FORCE_X,0) = 0.000000; -NODES[2360](BODY_FORCE_Y,0) = -9.810000; -NODES[2360](BODY_FORCE_Z,0) = 0.000000; -NODES[2361](BODY_FORCE_X,0) = 0.000000; -NODES[2361](BODY_FORCE_Y,0) = -9.810000; -NODES[2361](BODY_FORCE_Z,0) = 0.000000; -NODES[2362](BODY_FORCE_X,0) = 0.000000; -NODES[2362](BODY_FORCE_Y,0) = -9.810000; -NODES[2362](BODY_FORCE_Z,0) = 0.000000; -NODES[2363](BODY_FORCE_X,0) = 0.000000; -NODES[2363](BODY_FORCE_Y,0) = -9.810000; -NODES[2363](BODY_FORCE_Z,0) = 0.000000; -NODES[2364](BODY_FORCE_X,0) = 0.000000; -NODES[2364](BODY_FORCE_Y,0) = -9.810000; -NODES[2364](BODY_FORCE_Z,0) = 0.000000; -NODES[2365](BODY_FORCE_X,0) = 0.000000; -NODES[2365](BODY_FORCE_Y,0) = -9.810000; -NODES[2365](BODY_FORCE_Z,0) = 0.000000; -NODES[2366](BODY_FORCE_X,0) = 0.000000; -NODES[2366](BODY_FORCE_Y,0) = -9.810000; -NODES[2366](BODY_FORCE_Z,0) = 0.000000; -NODES[2368](BODY_FORCE_X,0) = 0.000000; -NODES[2368](BODY_FORCE_Y,0) = -9.810000; -NODES[2368](BODY_FORCE_Z,0) = 0.000000; -NODES[2369](BODY_FORCE_X,0) = 0.000000; -NODES[2369](BODY_FORCE_Y,0) = -9.810000; -NODES[2369](BODY_FORCE_Z,0) = 0.000000; -NODES[2370](BODY_FORCE_X,0) = 0.000000; -NODES[2370](BODY_FORCE_Y,0) = -9.810000; -NODES[2370](BODY_FORCE_Z,0) = 0.000000; -NODES[2371](BODY_FORCE_X,0) = 0.000000; -NODES[2371](BODY_FORCE_Y,0) = -9.810000; -NODES[2371](BODY_FORCE_Z,0) = 0.000000; -NODES[2372](BODY_FORCE_X,0) = 0.000000; -NODES[2372](BODY_FORCE_Y,0) = -9.810000; -NODES[2372](BODY_FORCE_Z,0) = 0.000000; -NODES[2373](BODY_FORCE_X,0) = 0.000000; -NODES[2373](BODY_FORCE_Y,0) = -9.810000; -NODES[2373](BODY_FORCE_Z,0) = 0.000000; -NODES[2374](BODY_FORCE_X,0) = 0.000000; -NODES[2374](BODY_FORCE_Y,0) = -9.810000; -NODES[2374](BODY_FORCE_Z,0) = 0.000000; -NODES[2375](BODY_FORCE_X,0) = 0.000000; -NODES[2375](BODY_FORCE_Y,0) = -9.810000; -NODES[2375](BODY_FORCE_Z,0) = 0.000000; -NODES[2376](BODY_FORCE_X,0) = 0.000000; -NODES[2376](BODY_FORCE_Y,0) = -9.810000; -NODES[2376](BODY_FORCE_Z,0) = 0.000000; -NODES[2377](BODY_FORCE_X,0) = 0.000000; -NODES[2377](BODY_FORCE_Y,0) = -9.810000; -NODES[2377](BODY_FORCE_Z,0) = 0.000000; -NODES[2378](BODY_FORCE_X,0) = 0.000000; -NODES[2378](BODY_FORCE_Y,0) = -9.810000; -NODES[2378](BODY_FORCE_Z,0) = 0.000000; -NODES[2379](BODY_FORCE_X,0) = 0.000000; -NODES[2379](BODY_FORCE_Y,0) = -9.810000; -NODES[2379](BODY_FORCE_Z,0) = 0.000000; -NODES[2380](BODY_FORCE_X,0) = 0.000000; -NODES[2380](BODY_FORCE_Y,0) = -9.810000; -NODES[2380](BODY_FORCE_Z,0) = 0.000000; -NODES[2381](BODY_FORCE_X,0) = 0.000000; -NODES[2381](BODY_FORCE_Y,0) = -9.810000; -NODES[2381](BODY_FORCE_Z,0) = 0.000000; -NODES[2382](BODY_FORCE_X,0) = 0.000000; -NODES[2382](BODY_FORCE_Y,0) = -9.810000; -NODES[2382](BODY_FORCE_Z,0) = 0.000000; -NODES[2383](BODY_FORCE_X,0) = 0.000000; -NODES[2383](BODY_FORCE_Y,0) = -9.810000; -NODES[2383](BODY_FORCE_Z,0) = 0.000000; -NODES[2384](BODY_FORCE_X,0) = 0.000000; -NODES[2384](BODY_FORCE_Y,0) = -9.810000; -NODES[2384](BODY_FORCE_Z,0) = 0.000000; -NODES[2385](BODY_FORCE_X,0) = 0.000000; -NODES[2385](BODY_FORCE_Y,0) = -9.810000; -NODES[2385](BODY_FORCE_Z,0) = 0.000000; -NODES[2386](BODY_FORCE_X,0) = 0.000000; -NODES[2386](BODY_FORCE_Y,0) = -9.810000; -NODES[2386](BODY_FORCE_Z,0) = 0.000000; -NODES[2387](BODY_FORCE_X,0) = 0.000000; -NODES[2387](BODY_FORCE_Y,0) = -9.810000; -NODES[2387](BODY_FORCE_Z,0) = 0.000000; -NODES[2388](BODY_FORCE_X,0) = 0.000000; -NODES[2388](BODY_FORCE_Y,0) = -9.810000; -NODES[2388](BODY_FORCE_Z,0) = 0.000000; -NODES[2389](BODY_FORCE_X,0) = 0.000000; -NODES[2389](BODY_FORCE_Y,0) = -9.810000; -NODES[2389](BODY_FORCE_Z,0) = 0.000000; -NODES[2390](BODY_FORCE_X,0) = 0.000000; -NODES[2390](BODY_FORCE_Y,0) = -9.810000; -NODES[2390](BODY_FORCE_Z,0) = 0.000000; -NODES[2391](BODY_FORCE_X,0) = 0.000000; -NODES[2391](BODY_FORCE_Y,0) = -9.810000; -NODES[2391](BODY_FORCE_Z,0) = 0.000000; -NODES[2392](BODY_FORCE_X,0) = 0.000000; -NODES[2392](BODY_FORCE_Y,0) = -9.810000; -NODES[2392](BODY_FORCE_Z,0) = 0.000000; -NODES[2393](BODY_FORCE_X,0) = 0.000000; -NODES[2393](BODY_FORCE_Y,0) = -9.810000; -NODES[2393](BODY_FORCE_Z,0) = 0.000000; -NODES[2394](BODY_FORCE_X,0) = 0.000000; -NODES[2394](BODY_FORCE_Y,0) = -9.810000; -NODES[2394](BODY_FORCE_Z,0) = 0.000000; -NODES[2395](BODY_FORCE_X,0) = 0.000000; -NODES[2395](BODY_FORCE_Y,0) = -9.810000; -NODES[2395](BODY_FORCE_Z,0) = 0.000000; -NODES[2396](BODY_FORCE_X,0) = 0.000000; -NODES[2396](BODY_FORCE_Y,0) = -9.810000; -NODES[2396](BODY_FORCE_Z,0) = 0.000000; -NODES[2398](BODY_FORCE_X,0) = 0.000000; -NODES[2398](BODY_FORCE_Y,0) = -9.810000; -NODES[2398](BODY_FORCE_Z,0) = 0.000000; -NODES[2399](BODY_FORCE_X,0) = 0.000000; -NODES[2399](BODY_FORCE_Y,0) = -9.810000; -NODES[2399](BODY_FORCE_Z,0) = 0.000000; -NODES[2400](BODY_FORCE_X,0) = 0.000000; -NODES[2400](BODY_FORCE_Y,0) = -9.810000; -NODES[2400](BODY_FORCE_Z,0) = 0.000000; -NODES[2401](BODY_FORCE_X,0) = 0.000000; -NODES[2401](BODY_FORCE_Y,0) = -9.810000; -NODES[2401](BODY_FORCE_Z,0) = 0.000000; -NODES[2402](BODY_FORCE_X,0) = 0.000000; -NODES[2402](BODY_FORCE_Y,0) = -9.810000; -NODES[2402](BODY_FORCE_Z,0) = 0.000000; -NODES[2403](BODY_FORCE_X,0) = 0.000000; -NODES[2403](BODY_FORCE_Y,0) = -9.810000; -NODES[2403](BODY_FORCE_Z,0) = 0.000000; -NODES[2404](BODY_FORCE_X,0) = 0.000000; -NODES[2404](BODY_FORCE_Y,0) = -9.810000; -NODES[2404](BODY_FORCE_Z,0) = 0.000000; -NODES[2405](BODY_FORCE_X,0) = 0.000000; -NODES[2405](BODY_FORCE_Y,0) = -9.810000; -NODES[2405](BODY_FORCE_Z,0) = 0.000000; -NODES[2406](BODY_FORCE_X,0) = 0.000000; -NODES[2406](BODY_FORCE_Y,0) = -9.810000; -NODES[2406](BODY_FORCE_Z,0) = 0.000000; -NODES[2407](BODY_FORCE_X,0) = 0.000000; -NODES[2407](BODY_FORCE_Y,0) = -9.810000; -NODES[2407](BODY_FORCE_Z,0) = 0.000000; -NODES[2408](BODY_FORCE_X,0) = 0.000000; -NODES[2408](BODY_FORCE_Y,0) = -9.810000; -NODES[2408](BODY_FORCE_Z,0) = 0.000000; -NODES[2409](BODY_FORCE_X,0) = 0.000000; -NODES[2409](BODY_FORCE_Y,0) = -9.810000; -NODES[2409](BODY_FORCE_Z,0) = 0.000000; -NODES[2410](BODY_FORCE_X,0) = 0.000000; -NODES[2410](BODY_FORCE_Y,0) = -9.810000; -NODES[2410](BODY_FORCE_Z,0) = 0.000000; -NODES[2411](BODY_FORCE_X,0) = 0.000000; -NODES[2411](BODY_FORCE_Y,0) = -9.810000; -NODES[2411](BODY_FORCE_Z,0) = 0.000000; -NODES[2412](BODY_FORCE_X,0) = 0.000000; -NODES[2412](BODY_FORCE_Y,0) = -9.810000; -NODES[2412](BODY_FORCE_Z,0) = 0.000000; -NODES[2413](BODY_FORCE_X,0) = 0.000000; -NODES[2413](BODY_FORCE_Y,0) = -9.810000; -NODES[2413](BODY_FORCE_Z,0) = 0.000000; -NODES[2414](BODY_FORCE_X,0) = 0.000000; -NODES[2414](BODY_FORCE_Y,0) = -9.810000; -NODES[2414](BODY_FORCE_Z,0) = 0.000000; -NODES[2415](BODY_FORCE_X,0) = 0.000000; -NODES[2415](BODY_FORCE_Y,0) = -9.810000; -NODES[2415](BODY_FORCE_Z,0) = 0.000000; -NODES[2416](BODY_FORCE_X,0) = 0.000000; -NODES[2416](BODY_FORCE_Y,0) = -9.810000; -NODES[2416](BODY_FORCE_Z,0) = 0.000000; -NODES[2417](BODY_FORCE_X,0) = 0.000000; -NODES[2417](BODY_FORCE_Y,0) = -9.810000; -NODES[2417](BODY_FORCE_Z,0) = 0.000000; -NODES[2418](BODY_FORCE_X,0) = 0.000000; -NODES[2418](BODY_FORCE_Y,0) = -9.810000; -NODES[2418](BODY_FORCE_Z,0) = 0.000000; -NODES[2419](BODY_FORCE_X,0) = 0.000000; -NODES[2419](BODY_FORCE_Y,0) = -9.810000; -NODES[2419](BODY_FORCE_Z,0) = 0.000000; -NODES[2420](BODY_FORCE_X,0) = 0.000000; -NODES[2420](BODY_FORCE_Y,0) = -9.810000; -NODES[2420](BODY_FORCE_Z,0) = 0.000000; -NODES[2421](BODY_FORCE_X,0) = 0.000000; -NODES[2421](BODY_FORCE_Y,0) = -9.810000; -NODES[2421](BODY_FORCE_Z,0) = 0.000000; -NODES[2422](BODY_FORCE_X,0) = 0.000000; -NODES[2422](BODY_FORCE_Y,0) = -9.810000; -NODES[2422](BODY_FORCE_Z,0) = 0.000000; -NODES[2423](BODY_FORCE_X,0) = 0.000000; -NODES[2423](BODY_FORCE_Y,0) = -9.810000; -NODES[2423](BODY_FORCE_Z,0) = 0.000000; -NODES[2424](BODY_FORCE_X,0) = 0.000000; -NODES[2424](BODY_FORCE_Y,0) = -9.810000; -NODES[2424](BODY_FORCE_Z,0) = 0.000000; -NODES[2425](BODY_FORCE_X,0) = 0.000000; -NODES[2425](BODY_FORCE_Y,0) = -9.810000; -NODES[2425](BODY_FORCE_Z,0) = 0.000000; -NODES[2426](BODY_FORCE_X,0) = 0.000000; -NODES[2426](BODY_FORCE_Y,0) = -9.810000; -NODES[2426](BODY_FORCE_Z,0) = 0.000000; -NODES[2427](BODY_FORCE_X,0) = 0.000000; -NODES[2427](BODY_FORCE_Y,0) = -9.810000; -NODES[2427](BODY_FORCE_Z,0) = 0.000000; -NODES[2429](BODY_FORCE_X,0) = 0.000000; -NODES[2429](BODY_FORCE_Y,0) = -9.810000; -NODES[2429](BODY_FORCE_Z,0) = 0.000000; -NODES[2430](BODY_FORCE_X,0) = 0.000000; -NODES[2430](BODY_FORCE_Y,0) = -9.810000; -NODES[2430](BODY_FORCE_Z,0) = 0.000000; -NODES[2431](BODY_FORCE_X,0) = 0.000000; -NODES[2431](BODY_FORCE_Y,0) = -9.810000; -NODES[2431](BODY_FORCE_Z,0) = 0.000000; -NODES[2432](BODY_FORCE_X,0) = 0.000000; -NODES[2432](BODY_FORCE_Y,0) = -9.810000; -NODES[2432](BODY_FORCE_Z,0) = 0.000000; -NODES[2433](BODY_FORCE_X,0) = 0.000000; -NODES[2433](BODY_FORCE_Y,0) = -9.810000; -NODES[2433](BODY_FORCE_Z,0) = 0.000000; -NODES[2434](BODY_FORCE_X,0) = 0.000000; -NODES[2434](BODY_FORCE_Y,0) = -9.810000; -NODES[2434](BODY_FORCE_Z,0) = 0.000000; -NODES[2435](BODY_FORCE_X,0) = 0.000000; -NODES[2435](BODY_FORCE_Y,0) = -9.810000; -NODES[2435](BODY_FORCE_Z,0) = 0.000000; -NODES[2436](BODY_FORCE_X,0) = 0.000000; -NODES[2436](BODY_FORCE_Y,0) = -9.810000; -NODES[2436](BODY_FORCE_Z,0) = 0.000000; -NODES[2437](BODY_FORCE_X,0) = 0.000000; -NODES[2437](BODY_FORCE_Y,0) = -9.810000; -NODES[2437](BODY_FORCE_Z,0) = 0.000000; -NODES[2438](BODY_FORCE_X,0) = 0.000000; -NODES[2438](BODY_FORCE_Y,0) = -9.810000; -NODES[2438](BODY_FORCE_Z,0) = 0.000000; -NODES[2439](BODY_FORCE_X,0) = 0.000000; -NODES[2439](BODY_FORCE_Y,0) = -9.810000; -NODES[2439](BODY_FORCE_Z,0) = 0.000000; -NODES[2440](BODY_FORCE_X,0) = 0.000000; -NODES[2440](BODY_FORCE_Y,0) = -9.810000; -NODES[2440](BODY_FORCE_Z,0) = 0.000000; -NODES[2441](BODY_FORCE_X,0) = 0.000000; -NODES[2441](BODY_FORCE_Y,0) = -9.810000; -NODES[2441](BODY_FORCE_Z,0) = 0.000000; -NODES[2442](BODY_FORCE_X,0) = 0.000000; -NODES[2442](BODY_FORCE_Y,0) = -9.810000; -NODES[2442](BODY_FORCE_Z,0) = 0.000000; -NODES[2443](BODY_FORCE_X,0) = 0.000000; -NODES[2443](BODY_FORCE_Y,0) = -9.810000; -NODES[2443](BODY_FORCE_Z,0) = 0.000000; -NODES[2444](BODY_FORCE_X,0) = 0.000000; -NODES[2444](BODY_FORCE_Y,0) = -9.810000; -NODES[2444](BODY_FORCE_Z,0) = 0.000000; -NODES[2445](BODY_FORCE_X,0) = 0.000000; -NODES[2445](BODY_FORCE_Y,0) = -9.810000; -NODES[2445](BODY_FORCE_Z,0) = 0.000000; -NODES[2446](BODY_FORCE_X,0) = 0.000000; -NODES[2446](BODY_FORCE_Y,0) = -9.810000; -NODES[2446](BODY_FORCE_Z,0) = 0.000000; -NODES[2447](BODY_FORCE_X,0) = 0.000000; -NODES[2447](BODY_FORCE_Y,0) = -9.810000; -NODES[2447](BODY_FORCE_Z,0) = 0.000000; -NODES[2448](BODY_FORCE_X,0) = 0.000000; -NODES[2448](BODY_FORCE_Y,0) = -9.810000; -NODES[2448](BODY_FORCE_Z,0) = 0.000000; -NODES[2449](BODY_FORCE_X,0) = 0.000000; -NODES[2449](BODY_FORCE_Y,0) = -9.810000; -NODES[2449](BODY_FORCE_Z,0) = 0.000000; -NODES[2450](BODY_FORCE_X,0) = 0.000000; -NODES[2450](BODY_FORCE_Y,0) = -9.810000; -NODES[2450](BODY_FORCE_Z,0) = 0.000000; -NODES[2451](BODY_FORCE_X,0) = 0.000000; -NODES[2451](BODY_FORCE_Y,0) = -9.810000; -NODES[2451](BODY_FORCE_Z,0) = 0.000000; -NODES[2452](BODY_FORCE_X,0) = 0.000000; -NODES[2452](BODY_FORCE_Y,0) = -9.810000; -NODES[2452](BODY_FORCE_Z,0) = 0.000000; -NODES[2453](BODY_FORCE_X,0) = 0.000000; -NODES[2453](BODY_FORCE_Y,0) = -9.810000; -NODES[2453](BODY_FORCE_Z,0) = 0.000000; -NODES[2454](BODY_FORCE_X,0) = 0.000000; -NODES[2454](BODY_FORCE_Y,0) = -9.810000; -NODES[2454](BODY_FORCE_Z,0) = 0.000000; -NODES[2455](BODY_FORCE_X,0) = 0.000000; -NODES[2455](BODY_FORCE_Y,0) = -9.810000; -NODES[2455](BODY_FORCE_Z,0) = 0.000000; -NODES[2456](BODY_FORCE_X,0) = 0.000000; -NODES[2456](BODY_FORCE_Y,0) = -9.810000; -NODES[2456](BODY_FORCE_Z,0) = 0.000000; -NODES[2457](BODY_FORCE_X,0) = 0.000000; -NODES[2457](BODY_FORCE_Y,0) = -9.810000; -NODES[2457](BODY_FORCE_Z,0) = 0.000000; -NODES[2458](BODY_FORCE_X,0) = 0.000000; -NODES[2458](BODY_FORCE_Y,0) = -9.810000; -NODES[2458](BODY_FORCE_Z,0) = 0.000000; -NODES[2459](BODY_FORCE_X,0) = 0.000000; -NODES[2459](BODY_FORCE_Y,0) = -9.810000; -NODES[2459](BODY_FORCE_Z,0) = 0.000000; -NODES[2460](BODY_FORCE_X,0) = 0.000000; -NODES[2460](BODY_FORCE_Y,0) = -9.810000; -NODES[2460](BODY_FORCE_Z,0) = 0.000000; -NODES[2461](BODY_FORCE_X,0) = 0.000000; -NODES[2461](BODY_FORCE_Y,0) = -9.810000; -NODES[2461](BODY_FORCE_Z,0) = 0.000000; -NODES[2463](BODY_FORCE_X,0) = 0.000000; -NODES[2463](BODY_FORCE_Y,0) = -9.810000; -NODES[2463](BODY_FORCE_Z,0) = 0.000000; -NODES[2464](BODY_FORCE_X,0) = 0.000000; -NODES[2464](BODY_FORCE_Y,0) = -9.810000; -NODES[2464](BODY_FORCE_Z,0) = 0.000000; -NODES[2465](BODY_FORCE_X,0) = 0.000000; -NODES[2465](BODY_FORCE_Y,0) = -9.810000; -NODES[2465](BODY_FORCE_Z,0) = 0.000000; -NODES[2466](BODY_FORCE_X,0) = 0.000000; -NODES[2466](BODY_FORCE_Y,0) = -9.810000; -NODES[2466](BODY_FORCE_Z,0) = 0.000000; -NODES[2467](BODY_FORCE_X,0) = 0.000000; -NODES[2467](BODY_FORCE_Y,0) = -9.810000; -NODES[2467](BODY_FORCE_Z,0) = 0.000000; -NODES[2468](BODY_FORCE_X,0) = 0.000000; -NODES[2468](BODY_FORCE_Y,0) = -9.810000; -NODES[2468](BODY_FORCE_Z,0) = 0.000000; -NODES[2469](BODY_FORCE_X,0) = 0.000000; -NODES[2469](BODY_FORCE_Y,0) = -9.810000; -NODES[2469](BODY_FORCE_Z,0) = 0.000000; -NODES[2470](BODY_FORCE_X,0) = 0.000000; -NODES[2470](BODY_FORCE_Y,0) = -9.810000; -NODES[2470](BODY_FORCE_Z,0) = 0.000000; -NODES[2471](BODY_FORCE_X,0) = 0.000000; -NODES[2471](BODY_FORCE_Y,0) = -9.810000; -NODES[2471](BODY_FORCE_Z,0) = 0.000000; -NODES[2472](BODY_FORCE_X,0) = 0.000000; -NODES[2472](BODY_FORCE_Y,0) = -9.810000; -NODES[2472](BODY_FORCE_Z,0) = 0.000000; -NODES[2473](BODY_FORCE_X,0) = 0.000000; -NODES[2473](BODY_FORCE_Y,0) = -9.810000; -NODES[2473](BODY_FORCE_Z,0) = 0.000000; -NODES[2474](BODY_FORCE_X,0) = 0.000000; -NODES[2474](BODY_FORCE_Y,0) = -9.810000; -NODES[2474](BODY_FORCE_Z,0) = 0.000000; -NODES[2475](BODY_FORCE_X,0) = 0.000000; -NODES[2475](BODY_FORCE_Y,0) = -9.810000; -NODES[2475](BODY_FORCE_Z,0) = 0.000000; -NODES[2476](BODY_FORCE_X,0) = 0.000000; -NODES[2476](BODY_FORCE_Y,0) = -9.810000; -NODES[2476](BODY_FORCE_Z,0) = 0.000000; -NODES[2477](BODY_FORCE_X,0) = 0.000000; -NODES[2477](BODY_FORCE_Y,0) = -9.810000; -NODES[2477](BODY_FORCE_Z,0) = 0.000000; -NODES[2478](BODY_FORCE_X,0) = 0.000000; -NODES[2478](BODY_FORCE_Y,0) = -9.810000; -NODES[2478](BODY_FORCE_Z,0) = 0.000000; -NODES[2479](BODY_FORCE_X,0) = 0.000000; -NODES[2479](BODY_FORCE_Y,0) = -9.810000; -NODES[2479](BODY_FORCE_Z,0) = 0.000000; -NODES[2480](BODY_FORCE_X,0) = 0.000000; -NODES[2480](BODY_FORCE_Y,0) = -9.810000; -NODES[2480](BODY_FORCE_Z,0) = 0.000000; -NODES[2481](BODY_FORCE_X,0) = 0.000000; -NODES[2481](BODY_FORCE_Y,0) = -9.810000; -NODES[2481](BODY_FORCE_Z,0) = 0.000000; -NODES[2482](BODY_FORCE_X,0) = 0.000000; -NODES[2482](BODY_FORCE_Y,0) = -9.810000; -NODES[2482](BODY_FORCE_Z,0) = 0.000000; -NODES[2483](BODY_FORCE_X,0) = 0.000000; -NODES[2483](BODY_FORCE_Y,0) = -9.810000; -NODES[2483](BODY_FORCE_Z,0) = 0.000000; -NODES[2484](BODY_FORCE_X,0) = 0.000000; -NODES[2484](BODY_FORCE_Y,0) = -9.810000; -NODES[2484](BODY_FORCE_Z,0) = 0.000000; -NODES[2485](BODY_FORCE_X,0) = 0.000000; -NODES[2485](BODY_FORCE_Y,0) = -9.810000; -NODES[2485](BODY_FORCE_Z,0) = 0.000000; -NODES[2486](BODY_FORCE_X,0) = 0.000000; -NODES[2486](BODY_FORCE_Y,0) = -9.810000; -NODES[2486](BODY_FORCE_Z,0) = 0.000000; -NODES[2487](BODY_FORCE_X,0) = 0.000000; -NODES[2487](BODY_FORCE_Y,0) = -9.810000; -NODES[2487](BODY_FORCE_Z,0) = 0.000000; -NODES[2488](BODY_FORCE_X,0) = 0.000000; -NODES[2488](BODY_FORCE_Y,0) = -9.810000; -NODES[2488](BODY_FORCE_Z,0) = 0.000000; -NODES[2489](BODY_FORCE_X,0) = 0.000000; -NODES[2489](BODY_FORCE_Y,0) = -9.810000; -NODES[2489](BODY_FORCE_Z,0) = 0.000000; -NODES[2490](BODY_FORCE_X,0) = 0.000000; -NODES[2490](BODY_FORCE_Y,0) = -9.810000; -NODES[2490](BODY_FORCE_Z,0) = 0.000000; -NODES[2491](BODY_FORCE_X,0) = 0.000000; -NODES[2491](BODY_FORCE_Y,0) = -9.810000; -NODES[2491](BODY_FORCE_Z,0) = 0.000000; -NODES[2493](BODY_FORCE_X,0) = 0.000000; -NODES[2493](BODY_FORCE_Y,0) = -9.810000; -NODES[2493](BODY_FORCE_Z,0) = 0.000000; -NODES[2494](BODY_FORCE_X,0) = 0.000000; -NODES[2494](BODY_FORCE_Y,0) = -9.810000; -NODES[2494](BODY_FORCE_Z,0) = 0.000000; -NODES[2495](BODY_FORCE_X,0) = 0.000000; -NODES[2495](BODY_FORCE_Y,0) = -9.810000; -NODES[2495](BODY_FORCE_Z,0) = 0.000000; -NODES[2496](BODY_FORCE_X,0) = 0.000000; -NODES[2496](BODY_FORCE_Y,0) = -9.810000; -NODES[2496](BODY_FORCE_Z,0) = 0.000000; -NODES[2497](BODY_FORCE_X,0) = 0.000000; -NODES[2497](BODY_FORCE_Y,0) = -9.810000; -NODES[2497](BODY_FORCE_Z,0) = 0.000000; -NODES[2498](BODY_FORCE_X,0) = 0.000000; -NODES[2498](BODY_FORCE_Y,0) = -9.810000; -NODES[2498](BODY_FORCE_Z,0) = 0.000000; -NODES[2499](BODY_FORCE_X,0) = 0.000000; -NODES[2499](BODY_FORCE_Y,0) = -9.810000; -NODES[2499](BODY_FORCE_Z,0) = 0.000000; -NODES[2500](BODY_FORCE_X,0) = 0.000000; -NODES[2500](BODY_FORCE_Y,0) = -9.810000; -NODES[2500](BODY_FORCE_Z,0) = 0.000000; -NODES[2501](BODY_FORCE_X,0) = 0.000000; -NODES[2501](BODY_FORCE_Y,0) = -9.810000; -NODES[2501](BODY_FORCE_Z,0) = 0.000000; -NODES[2502](BODY_FORCE_X,0) = 0.000000; -NODES[2502](BODY_FORCE_Y,0) = -9.810000; -NODES[2502](BODY_FORCE_Z,0) = 0.000000; -NODES[2503](BODY_FORCE_X,0) = 0.000000; -NODES[2503](BODY_FORCE_Y,0) = -9.810000; -NODES[2503](BODY_FORCE_Z,0) = 0.000000; -NODES[2504](BODY_FORCE_X,0) = 0.000000; -NODES[2504](BODY_FORCE_Y,0) = -9.810000; -NODES[2504](BODY_FORCE_Z,0) = 0.000000; -NODES[2505](BODY_FORCE_X,0) = 0.000000; -NODES[2505](BODY_FORCE_Y,0) = -9.810000; -NODES[2505](BODY_FORCE_Z,0) = 0.000000; -NODES[2506](BODY_FORCE_X,0) = 0.000000; -NODES[2506](BODY_FORCE_Y,0) = -9.810000; -NODES[2506](BODY_FORCE_Z,0) = 0.000000; -NODES[2507](BODY_FORCE_X,0) = 0.000000; -NODES[2507](BODY_FORCE_Y,0) = -9.810000; -NODES[2507](BODY_FORCE_Z,0) = 0.000000; -NODES[2508](BODY_FORCE_X,0) = 0.000000; -NODES[2508](BODY_FORCE_Y,0) = -9.810000; -NODES[2508](BODY_FORCE_Z,0) = 0.000000; -NODES[2509](BODY_FORCE_X,0) = 0.000000; -NODES[2509](BODY_FORCE_Y,0) = -9.810000; -NODES[2509](BODY_FORCE_Z,0) = 0.000000; -NODES[2510](BODY_FORCE_X,0) = 0.000000; -NODES[2510](BODY_FORCE_Y,0) = -9.810000; -NODES[2510](BODY_FORCE_Z,0) = 0.000000; -NODES[2511](BODY_FORCE_X,0) = 0.000000; -NODES[2511](BODY_FORCE_Y,0) = -9.810000; -NODES[2511](BODY_FORCE_Z,0) = 0.000000; -NODES[2512](BODY_FORCE_X,0) = 0.000000; -NODES[2512](BODY_FORCE_Y,0) = -9.810000; -NODES[2512](BODY_FORCE_Z,0) = 0.000000; -NODES[2513](BODY_FORCE_X,0) = 0.000000; -NODES[2513](BODY_FORCE_Y,0) = -9.810000; -NODES[2513](BODY_FORCE_Z,0) = 0.000000; -NODES[2514](BODY_FORCE_X,0) = 0.000000; -NODES[2514](BODY_FORCE_Y,0) = -9.810000; -NODES[2514](BODY_FORCE_Z,0) = 0.000000; -NODES[2515](BODY_FORCE_X,0) = 0.000000; -NODES[2515](BODY_FORCE_Y,0) = -9.810000; -NODES[2515](BODY_FORCE_Z,0) = 0.000000; -NODES[2516](BODY_FORCE_X,0) = 0.000000; -NODES[2516](BODY_FORCE_Y,0) = -9.810000; -NODES[2516](BODY_FORCE_Z,0) = 0.000000; -NODES[2517](BODY_FORCE_X,0) = 0.000000; -NODES[2517](BODY_FORCE_Y,0) = -9.810000; -NODES[2517](BODY_FORCE_Z,0) = 0.000000; -NODES[2518](BODY_FORCE_X,0) = 0.000000; -NODES[2518](BODY_FORCE_Y,0) = -9.810000; -NODES[2518](BODY_FORCE_Z,0) = 0.000000; -NODES[2519](BODY_FORCE_X,0) = 0.000000; -NODES[2519](BODY_FORCE_Y,0) = -9.810000; -NODES[2519](BODY_FORCE_Z,0) = 0.000000; -NODES[2520](BODY_FORCE_X,0) = 0.000000; -NODES[2520](BODY_FORCE_Y,0) = -9.810000; -NODES[2520](BODY_FORCE_Z,0) = 0.000000; -NODES[2521](BODY_FORCE_X,0) = 0.000000; -NODES[2521](BODY_FORCE_Y,0) = -9.810000; -NODES[2521](BODY_FORCE_Z,0) = 0.000000; -NODES[2523](BODY_FORCE_X,0) = 0.000000; -NODES[2523](BODY_FORCE_Y,0) = -9.810000; -NODES[2523](BODY_FORCE_Z,0) = 0.000000; -NODES[2524](BODY_FORCE_X,0) = 0.000000; -NODES[2524](BODY_FORCE_Y,0) = -9.810000; -NODES[2524](BODY_FORCE_Z,0) = 0.000000; -NODES[2525](BODY_FORCE_X,0) = 0.000000; -NODES[2525](BODY_FORCE_Y,0) = -9.810000; -NODES[2525](BODY_FORCE_Z,0) = 0.000000; -NODES[2526](BODY_FORCE_X,0) = 0.000000; -NODES[2526](BODY_FORCE_Y,0) = -9.810000; -NODES[2526](BODY_FORCE_Z,0) = 0.000000; -NODES[2527](BODY_FORCE_X,0) = 0.000000; -NODES[2527](BODY_FORCE_Y,0) = -9.810000; -NODES[2527](BODY_FORCE_Z,0) = 0.000000; -NODES[2528](BODY_FORCE_X,0) = 0.000000; -NODES[2528](BODY_FORCE_Y,0) = -9.810000; -NODES[2528](BODY_FORCE_Z,0) = 0.000000; -NODES[2529](BODY_FORCE_X,0) = 0.000000; -NODES[2529](BODY_FORCE_Y,0) = -9.810000; -NODES[2529](BODY_FORCE_Z,0) = 0.000000; -NODES[2530](BODY_FORCE_X,0) = 0.000000; -NODES[2530](BODY_FORCE_Y,0) = -9.810000; -NODES[2530](BODY_FORCE_Z,0) = 0.000000; -NODES[2531](BODY_FORCE_X,0) = 0.000000; -NODES[2531](BODY_FORCE_Y,0) = -9.810000; -NODES[2531](BODY_FORCE_Z,0) = 0.000000; -NODES[2532](BODY_FORCE_X,0) = 0.000000; -NODES[2532](BODY_FORCE_Y,0) = -9.810000; -NODES[2532](BODY_FORCE_Z,0) = 0.000000; -NODES[2533](BODY_FORCE_X,0) = 0.000000; -NODES[2533](BODY_FORCE_Y,0) = -9.810000; -NODES[2533](BODY_FORCE_Z,0) = 0.000000; -NODES[2534](BODY_FORCE_X,0) = 0.000000; -NODES[2534](BODY_FORCE_Y,0) = -9.810000; -NODES[2534](BODY_FORCE_Z,0) = 0.000000; -NODES[2535](BODY_FORCE_X,0) = 0.000000; -NODES[2535](BODY_FORCE_Y,0) = -9.810000; -NODES[2535](BODY_FORCE_Z,0) = 0.000000; -NODES[2536](BODY_FORCE_X,0) = 0.000000; -NODES[2536](BODY_FORCE_Y,0) = -9.810000; -NODES[2536](BODY_FORCE_Z,0) = 0.000000; -NODES[2537](BODY_FORCE_X,0) = 0.000000; -NODES[2537](BODY_FORCE_Y,0) = -9.810000; -NODES[2537](BODY_FORCE_Z,0) = 0.000000; -NODES[2538](BODY_FORCE_X,0) = 0.000000; -NODES[2538](BODY_FORCE_Y,0) = -9.810000; -NODES[2538](BODY_FORCE_Z,0) = 0.000000; -NODES[2539](BODY_FORCE_X,0) = 0.000000; -NODES[2539](BODY_FORCE_Y,0) = -9.810000; -NODES[2539](BODY_FORCE_Z,0) = 0.000000; -NODES[2540](BODY_FORCE_X,0) = 0.000000; -NODES[2540](BODY_FORCE_Y,0) = -9.810000; -NODES[2540](BODY_FORCE_Z,0) = 0.000000; -NODES[2541](BODY_FORCE_X,0) = 0.000000; -NODES[2541](BODY_FORCE_Y,0) = -9.810000; -NODES[2541](BODY_FORCE_Z,0) = 0.000000; -NODES[2542](BODY_FORCE_X,0) = 0.000000; -NODES[2542](BODY_FORCE_Y,0) = -9.810000; -NODES[2542](BODY_FORCE_Z,0) = 0.000000; -NODES[2543](BODY_FORCE_X,0) = 0.000000; -NODES[2543](BODY_FORCE_Y,0) = -9.810000; -NODES[2543](BODY_FORCE_Z,0) = 0.000000; -NODES[2544](BODY_FORCE_X,0) = 0.000000; -NODES[2544](BODY_FORCE_Y,0) = -9.810000; -NODES[2544](BODY_FORCE_Z,0) = 0.000000; -NODES[2545](BODY_FORCE_X,0) = 0.000000; -NODES[2545](BODY_FORCE_Y,0) = -9.810000; -NODES[2545](BODY_FORCE_Z,0) = 0.000000; -NODES[2546](BODY_FORCE_X,0) = 0.000000; -NODES[2546](BODY_FORCE_Y,0) = -9.810000; -NODES[2546](BODY_FORCE_Z,0) = 0.000000; -NODES[2547](BODY_FORCE_X,0) = 0.000000; -NODES[2547](BODY_FORCE_Y,0) = -9.810000; -NODES[2547](BODY_FORCE_Z,0) = 0.000000; -NODES[2548](BODY_FORCE_X,0) = 0.000000; -NODES[2548](BODY_FORCE_Y,0) = -9.810000; -NODES[2548](BODY_FORCE_Z,0) = 0.000000; -NODES[2549](BODY_FORCE_X,0) = 0.000000; -NODES[2549](BODY_FORCE_Y,0) = -9.810000; -NODES[2549](BODY_FORCE_Z,0) = 0.000000; -NODES[2550](BODY_FORCE_X,0) = 0.000000; -NODES[2550](BODY_FORCE_Y,0) = -9.810000; -NODES[2550](BODY_FORCE_Z,0) = 0.000000; -NODES[2552](BODY_FORCE_X,0) = 0.000000; -NODES[2552](BODY_FORCE_Y,0) = -9.810000; -NODES[2552](BODY_FORCE_Z,0) = 0.000000; -NODES[2553](BODY_FORCE_X,0) = 0.000000; -NODES[2553](BODY_FORCE_Y,0) = -9.810000; -NODES[2553](BODY_FORCE_Z,0) = 0.000000; -NODES[2554](BODY_FORCE_X,0) = 0.000000; -NODES[2554](BODY_FORCE_Y,0) = -9.810000; -NODES[2554](BODY_FORCE_Z,0) = 0.000000; -NODES[2555](BODY_FORCE_X,0) = 0.000000; -NODES[2555](BODY_FORCE_Y,0) = -9.810000; -NODES[2555](BODY_FORCE_Z,0) = 0.000000; -NODES[2556](BODY_FORCE_X,0) = 0.000000; -NODES[2556](BODY_FORCE_Y,0) = -9.810000; -NODES[2556](BODY_FORCE_Z,0) = 0.000000; -NODES[2557](BODY_FORCE_X,0) = 0.000000; -NODES[2557](BODY_FORCE_Y,0) = -9.810000; -NODES[2557](BODY_FORCE_Z,0) = 0.000000; -NODES[2558](BODY_FORCE_X,0) = 0.000000; -NODES[2558](BODY_FORCE_Y,0) = -9.810000; -NODES[2558](BODY_FORCE_Z,0) = 0.000000; -NODES[2559](BODY_FORCE_X,0) = 0.000000; -NODES[2559](BODY_FORCE_Y,0) = -9.810000; -NODES[2559](BODY_FORCE_Z,0) = 0.000000; -NODES[2560](BODY_FORCE_X,0) = 0.000000; -NODES[2560](BODY_FORCE_Y,0) = -9.810000; -NODES[2560](BODY_FORCE_Z,0) = 0.000000; -NODES[2561](BODY_FORCE_X,0) = 0.000000; -NODES[2561](BODY_FORCE_Y,0) = -9.810000; -NODES[2561](BODY_FORCE_Z,0) = 0.000000; -NODES[2562](BODY_FORCE_X,0) = 0.000000; -NODES[2562](BODY_FORCE_Y,0) = -9.810000; -NODES[2562](BODY_FORCE_Z,0) = 0.000000; -NODES[2563](BODY_FORCE_X,0) = 0.000000; -NODES[2563](BODY_FORCE_Y,0) = -9.810000; -NODES[2563](BODY_FORCE_Z,0) = 0.000000; -NODES[2564](BODY_FORCE_X,0) = 0.000000; -NODES[2564](BODY_FORCE_Y,0) = -9.810000; -NODES[2564](BODY_FORCE_Z,0) = 0.000000; -NODES[2565](BODY_FORCE_X,0) = 0.000000; -NODES[2565](BODY_FORCE_Y,0) = -9.810000; -NODES[2565](BODY_FORCE_Z,0) = 0.000000; -NODES[2566](BODY_FORCE_X,0) = 0.000000; -NODES[2566](BODY_FORCE_Y,0) = -9.810000; -NODES[2566](BODY_FORCE_Z,0) = 0.000000; -NODES[2567](BODY_FORCE_X,0) = 0.000000; -NODES[2567](BODY_FORCE_Y,0) = -9.810000; -NODES[2567](BODY_FORCE_Z,0) = 0.000000; -NODES[2568](BODY_FORCE_X,0) = 0.000000; -NODES[2568](BODY_FORCE_Y,0) = -9.810000; -NODES[2568](BODY_FORCE_Z,0) = 0.000000; -NODES[2569](BODY_FORCE_X,0) = 0.000000; -NODES[2569](BODY_FORCE_Y,0) = -9.810000; -NODES[2569](BODY_FORCE_Z,0) = 0.000000; -NODES[2570](BODY_FORCE_X,0) = 0.000000; -NODES[2570](BODY_FORCE_Y,0) = -9.810000; -NODES[2570](BODY_FORCE_Z,0) = 0.000000; -NODES[2571](BODY_FORCE_X,0) = 0.000000; -NODES[2571](BODY_FORCE_Y,0) = -9.810000; -NODES[2571](BODY_FORCE_Z,0) = 0.000000; -NODES[2572](BODY_FORCE_X,0) = 0.000000; -NODES[2572](BODY_FORCE_Y,0) = -9.810000; -NODES[2572](BODY_FORCE_Z,0) = 0.000000; -NODES[2573](BODY_FORCE_X,0) = 0.000000; -NODES[2573](BODY_FORCE_Y,0) = -9.810000; -NODES[2573](BODY_FORCE_Z,0) = 0.000000; -NODES[2574](BODY_FORCE_X,0) = 0.000000; -NODES[2574](BODY_FORCE_Y,0) = -9.810000; -NODES[2574](BODY_FORCE_Z,0) = 0.000000; -NODES[2575](BODY_FORCE_X,0) = 0.000000; -NODES[2575](BODY_FORCE_Y,0) = -9.810000; -NODES[2575](BODY_FORCE_Z,0) = 0.000000; -NODES[2576](BODY_FORCE_X,0) = 0.000000; -NODES[2576](BODY_FORCE_Y,0) = -9.810000; -NODES[2576](BODY_FORCE_Z,0) = 0.000000; -NODES[2577](BODY_FORCE_X,0) = 0.000000; -NODES[2577](BODY_FORCE_Y,0) = -9.810000; -NODES[2577](BODY_FORCE_Z,0) = 0.000000; -NODES[2578](BODY_FORCE_X,0) = 0.000000; -NODES[2578](BODY_FORCE_Y,0) = -9.810000; -NODES[2578](BODY_FORCE_Z,0) = 0.000000; -NODES[2579](BODY_FORCE_X,0) = 0.000000; -NODES[2579](BODY_FORCE_Y,0) = -9.810000; -NODES[2579](BODY_FORCE_Z,0) = 0.000000; -NODES[2580](BODY_FORCE_X,0) = 0.000000; -NODES[2580](BODY_FORCE_Y,0) = -9.810000; -NODES[2580](BODY_FORCE_Z,0) = 0.000000; -NODES[2581](BODY_FORCE_X,0) = 0.000000; -NODES[2581](BODY_FORCE_Y,0) = -9.810000; -NODES[2581](BODY_FORCE_Z,0) = 0.000000; -NODES[2583](BODY_FORCE_X,0) = 0.000000; -NODES[2583](BODY_FORCE_Y,0) = -9.810000; -NODES[2583](BODY_FORCE_Z,0) = 0.000000; -NODES[2584](BODY_FORCE_X,0) = 0.000000; -NODES[2584](BODY_FORCE_Y,0) = -9.810000; -NODES[2584](BODY_FORCE_Z,0) = 0.000000; -NODES[2585](BODY_FORCE_X,0) = 0.000000; -NODES[2585](BODY_FORCE_Y,0) = -9.810000; -NODES[2585](BODY_FORCE_Z,0) = 0.000000; -NODES[2586](BODY_FORCE_X,0) = 0.000000; -NODES[2586](BODY_FORCE_Y,0) = -9.810000; -NODES[2586](BODY_FORCE_Z,0) = 0.000000; -NODES[2587](BODY_FORCE_X,0) = 0.000000; -NODES[2587](BODY_FORCE_Y,0) = -9.810000; -NODES[2587](BODY_FORCE_Z,0) = 0.000000; -NODES[2588](BODY_FORCE_X,0) = 0.000000; -NODES[2588](BODY_FORCE_Y,0) = -9.810000; -NODES[2588](BODY_FORCE_Z,0) = 0.000000; -NODES[2589](BODY_FORCE_X,0) = 0.000000; -NODES[2589](BODY_FORCE_Y,0) = -9.810000; -NODES[2589](BODY_FORCE_Z,0) = 0.000000; -NODES[2590](BODY_FORCE_X,0) = 0.000000; -NODES[2590](BODY_FORCE_Y,0) = -9.810000; -NODES[2590](BODY_FORCE_Z,0) = 0.000000; -NODES[2591](BODY_FORCE_X,0) = 0.000000; -NODES[2591](BODY_FORCE_Y,0) = -9.810000; -NODES[2591](BODY_FORCE_Z,0) = 0.000000; -NODES[2592](BODY_FORCE_X,0) = 0.000000; -NODES[2592](BODY_FORCE_Y,0) = -9.810000; -NODES[2592](BODY_FORCE_Z,0) = 0.000000; -NODES[2593](BODY_FORCE_X,0) = 0.000000; -NODES[2593](BODY_FORCE_Y,0) = -9.810000; -NODES[2593](BODY_FORCE_Z,0) = 0.000000; -NODES[2594](BODY_FORCE_X,0) = 0.000000; -NODES[2594](BODY_FORCE_Y,0) = -9.810000; -NODES[2594](BODY_FORCE_Z,0) = 0.000000; -NODES[2595](BODY_FORCE_X,0) = 0.000000; -NODES[2595](BODY_FORCE_Y,0) = -9.810000; -NODES[2595](BODY_FORCE_Z,0) = 0.000000; -NODES[2596](BODY_FORCE_X,0) = 0.000000; -NODES[2596](BODY_FORCE_Y,0) = -9.810000; -NODES[2596](BODY_FORCE_Z,0) = 0.000000; -NODES[2597](BODY_FORCE_X,0) = 0.000000; -NODES[2597](BODY_FORCE_Y,0) = -9.810000; -NODES[2597](BODY_FORCE_Z,0) = 0.000000; -NODES[2598](BODY_FORCE_X,0) = 0.000000; -NODES[2598](BODY_FORCE_Y,0) = -9.810000; -NODES[2598](BODY_FORCE_Z,0) = 0.000000; -NODES[2599](BODY_FORCE_X,0) = 0.000000; -NODES[2599](BODY_FORCE_Y,0) = -9.810000; -NODES[2599](BODY_FORCE_Z,0) = 0.000000; -NODES[2600](BODY_FORCE_X,0) = 0.000000; -NODES[2600](BODY_FORCE_Y,0) = -9.810000; -NODES[2600](BODY_FORCE_Z,0) = 0.000000; -NODES[2601](BODY_FORCE_X,0) = 0.000000; -NODES[2601](BODY_FORCE_Y,0) = -9.810000; -NODES[2601](BODY_FORCE_Z,0) = 0.000000; -NODES[2602](BODY_FORCE_X,0) = 0.000000; -NODES[2602](BODY_FORCE_Y,0) = -9.810000; -NODES[2602](BODY_FORCE_Z,0) = 0.000000; -NODES[2603](BODY_FORCE_X,0) = 0.000000; -NODES[2603](BODY_FORCE_Y,0) = -9.810000; -NODES[2603](BODY_FORCE_Z,0) = 0.000000; -NODES[2604](BODY_FORCE_X,0) = 0.000000; -NODES[2604](BODY_FORCE_Y,0) = -9.810000; -NODES[2604](BODY_FORCE_Z,0) = 0.000000; -NODES[2605](BODY_FORCE_X,0) = 0.000000; -NODES[2605](BODY_FORCE_Y,0) = -9.810000; -NODES[2605](BODY_FORCE_Z,0) = 0.000000; -NODES[2606](BODY_FORCE_X,0) = 0.000000; -NODES[2606](BODY_FORCE_Y,0) = -9.810000; -NODES[2606](BODY_FORCE_Z,0) = 0.000000; -NODES[2607](BODY_FORCE_X,0) = 0.000000; -NODES[2607](BODY_FORCE_Y,0) = -9.810000; -NODES[2607](BODY_FORCE_Z,0) = 0.000000; -NODES[2608](BODY_FORCE_X,0) = 0.000000; -NODES[2608](BODY_FORCE_Y,0) = -9.810000; -NODES[2608](BODY_FORCE_Z,0) = 0.000000; -NODES[2609](BODY_FORCE_X,0) = 0.000000; -NODES[2609](BODY_FORCE_Y,0) = -9.810000; -NODES[2609](BODY_FORCE_Z,0) = 0.000000; -NODES[2610](BODY_FORCE_X,0) = 0.000000; -NODES[2610](BODY_FORCE_Y,0) = -9.810000; -NODES[2610](BODY_FORCE_Z,0) = 0.000000; -NODES[2611](BODY_FORCE_X,0) = 0.000000; -NODES[2611](BODY_FORCE_Y,0) = -9.810000; -NODES[2611](BODY_FORCE_Z,0) = 0.000000; -NODES[2613](BODY_FORCE_X,0) = 0.000000; -NODES[2613](BODY_FORCE_Y,0) = -9.810000; -NODES[2613](BODY_FORCE_Z,0) = 0.000000; -NODES[2614](BODY_FORCE_X,0) = 0.000000; -NODES[2614](BODY_FORCE_Y,0) = -9.810000; -NODES[2614](BODY_FORCE_Z,0) = 0.000000; -NODES[2615](BODY_FORCE_X,0) = 0.000000; -NODES[2615](BODY_FORCE_Y,0) = -9.810000; -NODES[2615](BODY_FORCE_Z,0) = 0.000000; -NODES[2616](BODY_FORCE_X,0) = 0.000000; -NODES[2616](BODY_FORCE_Y,0) = -9.810000; -NODES[2616](BODY_FORCE_Z,0) = 0.000000; -NODES[2617](BODY_FORCE_X,0) = 0.000000; -NODES[2617](BODY_FORCE_Y,0) = -9.810000; -NODES[2617](BODY_FORCE_Z,0) = 0.000000; -NODES[2618](BODY_FORCE_X,0) = 0.000000; -NODES[2618](BODY_FORCE_Y,0) = -9.810000; -NODES[2618](BODY_FORCE_Z,0) = 0.000000; -NODES[2619](BODY_FORCE_X,0) = 0.000000; -NODES[2619](BODY_FORCE_Y,0) = -9.810000; -NODES[2619](BODY_FORCE_Z,0) = 0.000000; -NODES[2620](BODY_FORCE_X,0) = 0.000000; -NODES[2620](BODY_FORCE_Y,0) = -9.810000; -NODES[2620](BODY_FORCE_Z,0) = 0.000000; -NODES[2621](BODY_FORCE_X,0) = 0.000000; -NODES[2621](BODY_FORCE_Y,0) = -9.810000; -NODES[2621](BODY_FORCE_Z,0) = 0.000000; -NODES[2622](BODY_FORCE_X,0) = 0.000000; -NODES[2622](BODY_FORCE_Y,0) = -9.810000; -NODES[2622](BODY_FORCE_Z,0) = 0.000000; -NODES[2623](BODY_FORCE_X,0) = 0.000000; -NODES[2623](BODY_FORCE_Y,0) = -9.810000; -NODES[2623](BODY_FORCE_Z,0) = 0.000000; -NODES[2624](BODY_FORCE_X,0) = 0.000000; -NODES[2624](BODY_FORCE_Y,0) = -9.810000; -NODES[2624](BODY_FORCE_Z,0) = 0.000000; -NODES[2625](BODY_FORCE_X,0) = 0.000000; -NODES[2625](BODY_FORCE_Y,0) = -9.810000; -NODES[2625](BODY_FORCE_Z,0) = 0.000000; -NODES[2626](BODY_FORCE_X,0) = 0.000000; -NODES[2626](BODY_FORCE_Y,0) = -9.810000; -NODES[2626](BODY_FORCE_Z,0) = 0.000000; -NODES[2627](BODY_FORCE_X,0) = 0.000000; -NODES[2627](BODY_FORCE_Y,0) = -9.810000; -NODES[2627](BODY_FORCE_Z,0) = 0.000000; -NODES[2628](BODY_FORCE_X,0) = 0.000000; -NODES[2628](BODY_FORCE_Y,0) = -9.810000; -NODES[2628](BODY_FORCE_Z,0) = 0.000000; -NODES[2629](BODY_FORCE_X,0) = 0.000000; -NODES[2629](BODY_FORCE_Y,0) = -9.810000; -NODES[2629](BODY_FORCE_Z,0) = 0.000000; -NODES[2630](BODY_FORCE_X,0) = 0.000000; -NODES[2630](BODY_FORCE_Y,0) = -9.810000; -NODES[2630](BODY_FORCE_Z,0) = 0.000000; -NODES[2631](BODY_FORCE_X,0) = 0.000000; -NODES[2631](BODY_FORCE_Y,0) = -9.810000; -NODES[2631](BODY_FORCE_Z,0) = 0.000000; -NODES[2632](BODY_FORCE_X,0) = 0.000000; -NODES[2632](BODY_FORCE_Y,0) = -9.810000; -NODES[2632](BODY_FORCE_Z,0) = 0.000000; -NODES[2633](BODY_FORCE_X,0) = 0.000000; -NODES[2633](BODY_FORCE_Y,0) = -9.810000; -NODES[2633](BODY_FORCE_Z,0) = 0.000000; -NODES[2634](BODY_FORCE_X,0) = 0.000000; -NODES[2634](BODY_FORCE_Y,0) = -9.810000; -NODES[2634](BODY_FORCE_Z,0) = 0.000000; -NODES[2635](BODY_FORCE_X,0) = 0.000000; -NODES[2635](BODY_FORCE_Y,0) = -9.810000; -NODES[2635](BODY_FORCE_Z,0) = 0.000000; -NODES[2636](BODY_FORCE_X,0) = 0.000000; -NODES[2636](BODY_FORCE_Y,0) = -9.810000; -NODES[2636](BODY_FORCE_Z,0) = 0.000000; -NODES[2637](BODY_FORCE_X,0) = 0.000000; -NODES[2637](BODY_FORCE_Y,0) = -9.810000; -NODES[2637](BODY_FORCE_Z,0) = 0.000000; -NODES[2638](BODY_FORCE_X,0) = 0.000000; -NODES[2638](BODY_FORCE_Y,0) = -9.810000; -NODES[2638](BODY_FORCE_Z,0) = 0.000000; -NODES[2639](BODY_FORCE_X,0) = 0.000000; -NODES[2639](BODY_FORCE_Y,0) = -9.810000; -NODES[2639](BODY_FORCE_Z,0) = 0.000000; -NODES[2640](BODY_FORCE_X,0) = 0.000000; -NODES[2640](BODY_FORCE_Y,0) = -9.810000; -NODES[2640](BODY_FORCE_Z,0) = 0.000000; -NODES[2641](BODY_FORCE_X,0) = 0.000000; -NODES[2641](BODY_FORCE_Y,0) = -9.810000; -NODES[2641](BODY_FORCE_Z,0) = 0.000000; -NODES[2643](BODY_FORCE_X,0) = 0.000000; -NODES[2643](BODY_FORCE_Y,0) = -9.810000; -NODES[2643](BODY_FORCE_Z,0) = 0.000000; -NODES[2644](BODY_FORCE_X,0) = 0.000000; -NODES[2644](BODY_FORCE_Y,0) = -9.810000; -NODES[2644](BODY_FORCE_Z,0) = 0.000000; -NODES[2645](BODY_FORCE_X,0) = 0.000000; -NODES[2645](BODY_FORCE_Y,0) = -9.810000; -NODES[2645](BODY_FORCE_Z,0) = 0.000000; -NODES[2646](BODY_FORCE_X,0) = 0.000000; -NODES[2646](BODY_FORCE_Y,0) = -9.810000; -NODES[2646](BODY_FORCE_Z,0) = 0.000000; -NODES[2647](BODY_FORCE_X,0) = 0.000000; -NODES[2647](BODY_FORCE_Y,0) = -9.810000; -NODES[2647](BODY_FORCE_Z,0) = 0.000000; -NODES[2648](BODY_FORCE_X,0) = 0.000000; -NODES[2648](BODY_FORCE_Y,0) = -9.810000; -NODES[2648](BODY_FORCE_Z,0) = 0.000000; -NODES[2649](BODY_FORCE_X,0) = 0.000000; -NODES[2649](BODY_FORCE_Y,0) = -9.810000; -NODES[2649](BODY_FORCE_Z,0) = 0.000000; -NODES[2650](BODY_FORCE_X,0) = 0.000000; -NODES[2650](BODY_FORCE_Y,0) = -9.810000; -NODES[2650](BODY_FORCE_Z,0) = 0.000000; -NODES[2651](BODY_FORCE_X,0) = 0.000000; -NODES[2651](BODY_FORCE_Y,0) = -9.810000; -NODES[2651](BODY_FORCE_Z,0) = 0.000000; -NODES[2652](BODY_FORCE_X,0) = 0.000000; -NODES[2652](BODY_FORCE_Y,0) = -9.810000; -NODES[2652](BODY_FORCE_Z,0) = 0.000000; -NODES[2653](BODY_FORCE_X,0) = 0.000000; -NODES[2653](BODY_FORCE_Y,0) = -9.810000; -NODES[2653](BODY_FORCE_Z,0) = 0.000000; -NODES[2654](BODY_FORCE_X,0) = 0.000000; -NODES[2654](BODY_FORCE_Y,0) = -9.810000; -NODES[2654](BODY_FORCE_Z,0) = 0.000000; -NODES[2655](BODY_FORCE_X,0) = 0.000000; -NODES[2655](BODY_FORCE_Y,0) = -9.810000; -NODES[2655](BODY_FORCE_Z,0) = 0.000000; -NODES[2656](BODY_FORCE_X,0) = 0.000000; -NODES[2656](BODY_FORCE_Y,0) = -9.810000; -NODES[2656](BODY_FORCE_Z,0) = 0.000000; -NODES[2657](BODY_FORCE_X,0) = 0.000000; -NODES[2657](BODY_FORCE_Y,0) = -9.810000; -NODES[2657](BODY_FORCE_Z,0) = 0.000000; -NODES[2658](BODY_FORCE_X,0) = 0.000000; -NODES[2658](BODY_FORCE_Y,0) = -9.810000; -NODES[2658](BODY_FORCE_Z,0) = 0.000000; -NODES[2659](BODY_FORCE_X,0) = 0.000000; -NODES[2659](BODY_FORCE_Y,0) = -9.810000; -NODES[2659](BODY_FORCE_Z,0) = 0.000000; -NODES[2660](BODY_FORCE_X,0) = 0.000000; -NODES[2660](BODY_FORCE_Y,0) = -9.810000; -NODES[2660](BODY_FORCE_Z,0) = 0.000000; -NODES[2661](BODY_FORCE_X,0) = 0.000000; -NODES[2661](BODY_FORCE_Y,0) = -9.810000; -NODES[2661](BODY_FORCE_Z,0) = 0.000000; -NODES[2662](BODY_FORCE_X,0) = 0.000000; -NODES[2662](BODY_FORCE_Y,0) = -9.810000; -NODES[2662](BODY_FORCE_Z,0) = 0.000000; -NODES[2663](BODY_FORCE_X,0) = 0.000000; -NODES[2663](BODY_FORCE_Y,0) = -9.810000; -NODES[2663](BODY_FORCE_Z,0) = 0.000000; -NODES[2664](BODY_FORCE_X,0) = 0.000000; -NODES[2664](BODY_FORCE_Y,0) = -9.810000; -NODES[2664](BODY_FORCE_Z,0) = 0.000000; -NODES[2665](BODY_FORCE_X,0) = 0.000000; -NODES[2665](BODY_FORCE_Y,0) = -9.810000; -NODES[2665](BODY_FORCE_Z,0) = 0.000000; -NODES[2666](BODY_FORCE_X,0) = 0.000000; -NODES[2666](BODY_FORCE_Y,0) = -9.810000; -NODES[2666](BODY_FORCE_Z,0) = 0.000000; -NODES[2667](BODY_FORCE_X,0) = 0.000000; -NODES[2667](BODY_FORCE_Y,0) = -9.810000; -NODES[2667](BODY_FORCE_Z,0) = 0.000000; -NODES[2668](BODY_FORCE_X,0) = 0.000000; -NODES[2668](BODY_FORCE_Y,0) = -9.810000; -NODES[2668](BODY_FORCE_Z,0) = 0.000000; -NODES[2669](BODY_FORCE_X,0) = 0.000000; -NODES[2669](BODY_FORCE_Y,0) = -9.810000; -NODES[2669](BODY_FORCE_Z,0) = 0.000000; -NODES[2670](BODY_FORCE_X,0) = 0.000000; -NODES[2670](BODY_FORCE_Y,0) = -9.810000; -NODES[2670](BODY_FORCE_Z,0) = 0.000000; -NODES[2672](BODY_FORCE_X,0) = 0.000000; -NODES[2672](BODY_FORCE_Y,0) = -9.810000; -NODES[2672](BODY_FORCE_Z,0) = 0.000000; -NODES[2673](BODY_FORCE_X,0) = 0.000000; -NODES[2673](BODY_FORCE_Y,0) = -9.810000; -NODES[2673](BODY_FORCE_Z,0) = 0.000000; -NODES[2674](BODY_FORCE_X,0) = 0.000000; -NODES[2674](BODY_FORCE_Y,0) = -9.810000; -NODES[2674](BODY_FORCE_Z,0) = 0.000000; -NODES[2675](BODY_FORCE_X,0) = 0.000000; -NODES[2675](BODY_FORCE_Y,0) = -9.810000; -NODES[2675](BODY_FORCE_Z,0) = 0.000000; -NODES[2676](BODY_FORCE_X,0) = 0.000000; -NODES[2676](BODY_FORCE_Y,0) = -9.810000; -NODES[2676](BODY_FORCE_Z,0) = 0.000000; -NODES[2677](BODY_FORCE_X,0) = 0.000000; -NODES[2677](BODY_FORCE_Y,0) = -9.810000; -NODES[2677](BODY_FORCE_Z,0) = 0.000000; -NODES[2678](BODY_FORCE_X,0) = 0.000000; -NODES[2678](BODY_FORCE_Y,0) = -9.810000; -NODES[2678](BODY_FORCE_Z,0) = 0.000000; -NODES[2679](BODY_FORCE_X,0) = 0.000000; -NODES[2679](BODY_FORCE_Y,0) = -9.810000; -NODES[2679](BODY_FORCE_Z,0) = 0.000000; -NODES[2680](BODY_FORCE_X,0) = 0.000000; -NODES[2680](BODY_FORCE_Y,0) = -9.810000; -NODES[2680](BODY_FORCE_Z,0) = 0.000000; -NODES[2681](BODY_FORCE_X,0) = 0.000000; -NODES[2681](BODY_FORCE_Y,0) = -9.810000; -NODES[2681](BODY_FORCE_Z,0) = 0.000000; -NODES[2682](BODY_FORCE_X,0) = 0.000000; -NODES[2682](BODY_FORCE_Y,0) = -9.810000; -NODES[2682](BODY_FORCE_Z,0) = 0.000000; -NODES[2683](BODY_FORCE_X,0) = 0.000000; -NODES[2683](BODY_FORCE_Y,0) = -9.810000; -NODES[2683](BODY_FORCE_Z,0) = 0.000000; -NODES[2684](BODY_FORCE_X,0) = 0.000000; -NODES[2684](BODY_FORCE_Y,0) = -9.810000; -NODES[2684](BODY_FORCE_Z,0) = 0.000000; -NODES[2685](BODY_FORCE_X,0) = 0.000000; -NODES[2685](BODY_FORCE_Y,0) = -9.810000; -NODES[2685](BODY_FORCE_Z,0) = 0.000000; -NODES[2686](BODY_FORCE_X,0) = 0.000000; -NODES[2686](BODY_FORCE_Y,0) = -9.810000; -NODES[2686](BODY_FORCE_Z,0) = 0.000000; -NODES[2687](BODY_FORCE_X,0) = 0.000000; -NODES[2687](BODY_FORCE_Y,0) = -9.810000; -NODES[2687](BODY_FORCE_Z,0) = 0.000000; -NODES[2688](BODY_FORCE_X,0) = 0.000000; -NODES[2688](BODY_FORCE_Y,0) = -9.810000; -NODES[2688](BODY_FORCE_Z,0) = 0.000000; -NODES[2689](BODY_FORCE_X,0) = 0.000000; -NODES[2689](BODY_FORCE_Y,0) = -9.810000; -NODES[2689](BODY_FORCE_Z,0) = 0.000000; -NODES[2690](BODY_FORCE_X,0) = 0.000000; -NODES[2690](BODY_FORCE_Y,0) = -9.810000; -NODES[2690](BODY_FORCE_Z,0) = 0.000000; -NODES[2691](BODY_FORCE_X,0) = 0.000000; -NODES[2691](BODY_FORCE_Y,0) = -9.810000; -NODES[2691](BODY_FORCE_Z,0) = 0.000000; -NODES[2692](BODY_FORCE_X,0) = 0.000000; -NODES[2692](BODY_FORCE_Y,0) = -9.810000; -NODES[2692](BODY_FORCE_Z,0) = 0.000000; -NODES[2693](BODY_FORCE_X,0) = 0.000000; -NODES[2693](BODY_FORCE_Y,0) = -9.810000; -NODES[2693](BODY_FORCE_Z,0) = 0.000000; -NODES[2694](BODY_FORCE_X,0) = 0.000000; -NODES[2694](BODY_FORCE_Y,0) = -9.810000; -NODES[2694](BODY_FORCE_Z,0) = 0.000000; -NODES[2695](BODY_FORCE_X,0) = 0.000000; -NODES[2695](BODY_FORCE_Y,0) = -9.810000; -NODES[2695](BODY_FORCE_Z,0) = 0.000000; -NODES[2696](BODY_FORCE_X,0) = 0.000000; -NODES[2696](BODY_FORCE_Y,0) = -9.810000; -NODES[2696](BODY_FORCE_Z,0) = 0.000000; -NODES[2697](BODY_FORCE_X,0) = 0.000000; -NODES[2697](BODY_FORCE_Y,0) = -9.810000; -NODES[2697](BODY_FORCE_Z,0) = 0.000000; -NODES[2698](BODY_FORCE_X,0) = 0.000000; -NODES[2698](BODY_FORCE_Y,0) = -9.810000; -NODES[2698](BODY_FORCE_Z,0) = 0.000000; -NODES[2699](BODY_FORCE_X,0) = 0.000000; -NODES[2699](BODY_FORCE_Y,0) = -9.810000; -NODES[2699](BODY_FORCE_Z,0) = 0.000000; -NODES[2700](BODY_FORCE_X,0) = 0.000000; -NODES[2700](BODY_FORCE_Y,0) = -9.810000; -NODES[2700](BODY_FORCE_Z,0) = 0.000000; -NODES[2701](BODY_FORCE_X,0) = 0.000000; -NODES[2701](BODY_FORCE_Y,0) = -9.810000; -NODES[2701](BODY_FORCE_Z,0) = 0.000000; -NODES[2703](BODY_FORCE_X,0) = 0.000000; -NODES[2703](BODY_FORCE_Y,0) = -9.810000; -NODES[2703](BODY_FORCE_Z,0) = 0.000000; -NODES[2704](BODY_FORCE_X,0) = 0.000000; -NODES[2704](BODY_FORCE_Y,0) = -9.810000; -NODES[2704](BODY_FORCE_Z,0) = 0.000000; -NODES[2705](BODY_FORCE_X,0) = 0.000000; -NODES[2705](BODY_FORCE_Y,0) = -9.810000; -NODES[2705](BODY_FORCE_Z,0) = 0.000000; -NODES[2706](BODY_FORCE_X,0) = 0.000000; -NODES[2706](BODY_FORCE_Y,0) = -9.810000; -NODES[2706](BODY_FORCE_Z,0) = 0.000000; -NODES[2707](BODY_FORCE_X,0) = 0.000000; -NODES[2707](BODY_FORCE_Y,0) = -9.810000; -NODES[2707](BODY_FORCE_Z,0) = 0.000000; -NODES[2708](BODY_FORCE_X,0) = 0.000000; -NODES[2708](BODY_FORCE_Y,0) = -9.810000; -NODES[2708](BODY_FORCE_Z,0) = 0.000000; -NODES[2709](BODY_FORCE_X,0) = 0.000000; -NODES[2709](BODY_FORCE_Y,0) = -9.810000; -NODES[2709](BODY_FORCE_Z,0) = 0.000000; -NODES[2710](BODY_FORCE_X,0) = 0.000000; -NODES[2710](BODY_FORCE_Y,0) = -9.810000; -NODES[2710](BODY_FORCE_Z,0) = 0.000000; -NODES[2711](BODY_FORCE_X,0) = 0.000000; -NODES[2711](BODY_FORCE_Y,0) = -9.810000; -NODES[2711](BODY_FORCE_Z,0) = 0.000000; -NODES[2712](BODY_FORCE_X,0) = 0.000000; -NODES[2712](BODY_FORCE_Y,0) = -9.810000; -NODES[2712](BODY_FORCE_Z,0) = 0.000000; -NODES[2713](BODY_FORCE_X,0) = 0.000000; -NODES[2713](BODY_FORCE_Y,0) = -9.810000; -NODES[2713](BODY_FORCE_Z,0) = 0.000000; -NODES[2714](BODY_FORCE_X,0) = 0.000000; -NODES[2714](BODY_FORCE_Y,0) = -9.810000; -NODES[2714](BODY_FORCE_Z,0) = 0.000000; -NODES[2715](BODY_FORCE_X,0) = 0.000000; -NODES[2715](BODY_FORCE_Y,0) = -9.810000; -NODES[2715](BODY_FORCE_Z,0) = 0.000000; -NODES[2716](BODY_FORCE_X,0) = 0.000000; -NODES[2716](BODY_FORCE_Y,0) = -9.810000; -NODES[2716](BODY_FORCE_Z,0) = 0.000000; -NODES[2717](BODY_FORCE_X,0) = 0.000000; -NODES[2717](BODY_FORCE_Y,0) = -9.810000; -NODES[2717](BODY_FORCE_Z,0) = 0.000000; -NODES[2718](BODY_FORCE_X,0) = 0.000000; -NODES[2718](BODY_FORCE_Y,0) = -9.810000; -NODES[2718](BODY_FORCE_Z,0) = 0.000000; -NODES[2719](BODY_FORCE_X,0) = 0.000000; -NODES[2719](BODY_FORCE_Y,0) = -9.810000; -NODES[2719](BODY_FORCE_Z,0) = 0.000000; -NODES[2720](BODY_FORCE_X,0) = 0.000000; -NODES[2720](BODY_FORCE_Y,0) = -9.810000; -NODES[2720](BODY_FORCE_Z,0) = 0.000000; -NODES[2721](BODY_FORCE_X,0) = 0.000000; -NODES[2721](BODY_FORCE_Y,0) = -9.810000; -NODES[2721](BODY_FORCE_Z,0) = 0.000000; -NODES[2722](BODY_FORCE_X,0) = 0.000000; -NODES[2722](BODY_FORCE_Y,0) = -9.810000; -NODES[2722](BODY_FORCE_Z,0) = 0.000000; -NODES[2723](BODY_FORCE_X,0) = 0.000000; -NODES[2723](BODY_FORCE_Y,0) = -9.810000; -NODES[2723](BODY_FORCE_Z,0) = 0.000000; -NODES[2724](BODY_FORCE_X,0) = 0.000000; -NODES[2724](BODY_FORCE_Y,0) = -9.810000; -NODES[2724](BODY_FORCE_Z,0) = 0.000000; -NODES[2725](BODY_FORCE_X,0) = 0.000000; -NODES[2725](BODY_FORCE_Y,0) = -9.810000; -NODES[2725](BODY_FORCE_Z,0) = 0.000000; -NODES[2726](BODY_FORCE_X,0) = 0.000000; -NODES[2726](BODY_FORCE_Y,0) = -9.810000; -NODES[2726](BODY_FORCE_Z,0) = 0.000000; -NODES[2727](BODY_FORCE_X,0) = 0.000000; -NODES[2727](BODY_FORCE_Y,0) = -9.810000; -NODES[2727](BODY_FORCE_Z,0) = 0.000000; -NODES[2728](BODY_FORCE_X,0) = 0.000000; -NODES[2728](BODY_FORCE_Y,0) = -9.810000; -NODES[2728](BODY_FORCE_Z,0) = 0.000000; -NODES[2729](BODY_FORCE_X,0) = 0.000000; -NODES[2729](BODY_FORCE_Y,0) = -9.810000; -NODES[2729](BODY_FORCE_Z,0) = 0.000000; -NODES[2730](BODY_FORCE_X,0) = 0.000000; -NODES[2730](BODY_FORCE_Y,0) = -9.810000; -NODES[2730](BODY_FORCE_Z,0) = 0.000000; -NODES[2732](BODY_FORCE_X,0) = 0.000000; -NODES[2732](BODY_FORCE_Y,0) = -9.810000; -NODES[2732](BODY_FORCE_Z,0) = 0.000000; -NODES[2733](BODY_FORCE_X,0) = 0.000000; -NODES[2733](BODY_FORCE_Y,0) = -9.810000; -NODES[2733](BODY_FORCE_Z,0) = 0.000000; -NODES[2734](BODY_FORCE_X,0) = 0.000000; -NODES[2734](BODY_FORCE_Y,0) = -9.810000; -NODES[2734](BODY_FORCE_Z,0) = 0.000000; -NODES[2735](BODY_FORCE_X,0) = 0.000000; -NODES[2735](BODY_FORCE_Y,0) = -9.810000; -NODES[2735](BODY_FORCE_Z,0) = 0.000000; -NODES[2736](BODY_FORCE_X,0) = 0.000000; -NODES[2736](BODY_FORCE_Y,0) = -9.810000; -NODES[2736](BODY_FORCE_Z,0) = 0.000000; -NODES[2737](BODY_FORCE_X,0) = 0.000000; -NODES[2737](BODY_FORCE_Y,0) = -9.810000; -NODES[2737](BODY_FORCE_Z,0) = 0.000000; -NODES[2738](BODY_FORCE_X,0) = 0.000000; -NODES[2738](BODY_FORCE_Y,0) = -9.810000; -NODES[2738](BODY_FORCE_Z,0) = 0.000000; -NODES[2739](BODY_FORCE_X,0) = 0.000000; -NODES[2739](BODY_FORCE_Y,0) = -9.810000; -NODES[2739](BODY_FORCE_Z,0) = 0.000000; -NODES[2740](BODY_FORCE_X,0) = 0.000000; -NODES[2740](BODY_FORCE_Y,0) = -9.810000; -NODES[2740](BODY_FORCE_Z,0) = 0.000000; -NODES[2741](BODY_FORCE_X,0) = 0.000000; -NODES[2741](BODY_FORCE_Y,0) = -9.810000; -NODES[2741](BODY_FORCE_Z,0) = 0.000000; -NODES[2742](BODY_FORCE_X,0) = 0.000000; -NODES[2742](BODY_FORCE_Y,0) = -9.810000; -NODES[2742](BODY_FORCE_Z,0) = 0.000000; -NODES[2743](BODY_FORCE_X,0) = 0.000000; -NODES[2743](BODY_FORCE_Y,0) = -9.810000; -NODES[2743](BODY_FORCE_Z,0) = 0.000000; -NODES[2744](BODY_FORCE_X,0) = 0.000000; -NODES[2744](BODY_FORCE_Y,0) = -9.810000; -NODES[2744](BODY_FORCE_Z,0) = 0.000000; -NODES[2745](BODY_FORCE_X,0) = 0.000000; -NODES[2745](BODY_FORCE_Y,0) = -9.810000; -NODES[2745](BODY_FORCE_Z,0) = 0.000000; -NODES[2746](BODY_FORCE_X,0) = 0.000000; -NODES[2746](BODY_FORCE_Y,0) = -9.810000; -NODES[2746](BODY_FORCE_Z,0) = 0.000000; -NODES[2747](BODY_FORCE_X,0) = 0.000000; -NODES[2747](BODY_FORCE_Y,0) = -9.810000; -NODES[2747](BODY_FORCE_Z,0) = 0.000000; -NODES[2748](BODY_FORCE_X,0) = 0.000000; -NODES[2748](BODY_FORCE_Y,0) = -9.810000; -NODES[2748](BODY_FORCE_Z,0) = 0.000000; -NODES[2749](BODY_FORCE_X,0) = 0.000000; -NODES[2749](BODY_FORCE_Y,0) = -9.810000; -NODES[2749](BODY_FORCE_Z,0) = 0.000000; -NODES[2750](BODY_FORCE_X,0) = 0.000000; -NODES[2750](BODY_FORCE_Y,0) = -9.810000; -NODES[2750](BODY_FORCE_Z,0) = 0.000000; -NODES[2751](BODY_FORCE_X,0) = 0.000000; -NODES[2751](BODY_FORCE_Y,0) = -9.810000; -NODES[2751](BODY_FORCE_Z,0) = 0.000000; -NODES[2752](BODY_FORCE_X,0) = 0.000000; -NODES[2752](BODY_FORCE_Y,0) = -9.810000; -NODES[2752](BODY_FORCE_Z,0) = 0.000000; -NODES[2753](BODY_FORCE_X,0) = 0.000000; -NODES[2753](BODY_FORCE_Y,0) = -9.810000; -NODES[2753](BODY_FORCE_Z,0) = 0.000000; -NODES[2754](BODY_FORCE_X,0) = 0.000000; -NODES[2754](BODY_FORCE_Y,0) = -9.810000; -NODES[2754](BODY_FORCE_Z,0) = 0.000000; -NODES[2755](BODY_FORCE_X,0) = 0.000000; -NODES[2755](BODY_FORCE_Y,0) = -9.810000; -NODES[2755](BODY_FORCE_Z,0) = 0.000000; -NODES[2756](BODY_FORCE_X,0) = 0.000000; -NODES[2756](BODY_FORCE_Y,0) = -9.810000; -NODES[2756](BODY_FORCE_Z,0) = 0.000000; -NODES[2757](BODY_FORCE_X,0) = 0.000000; -NODES[2757](BODY_FORCE_Y,0) = -9.810000; -NODES[2757](BODY_FORCE_Z,0) = 0.000000; -NODES[2758](BODY_FORCE_X,0) = 0.000000; -NODES[2758](BODY_FORCE_Y,0) = -9.810000; -NODES[2758](BODY_FORCE_Z,0) = 0.000000; -NODES[2759](BODY_FORCE_X,0) = 0.000000; -NODES[2759](BODY_FORCE_Y,0) = -9.810000; -NODES[2759](BODY_FORCE_Z,0) = 0.000000; -NODES[2761](BODY_FORCE_X,0) = 0.000000; -NODES[2761](BODY_FORCE_Y,0) = -9.810000; -NODES[2761](BODY_FORCE_Z,0) = 0.000000; -NODES[2762](BODY_FORCE_X,0) = 0.000000; -NODES[2762](BODY_FORCE_Y,0) = -9.810000; -NODES[2762](BODY_FORCE_Z,0) = 0.000000; -NODES[2763](BODY_FORCE_X,0) = 0.000000; -NODES[2763](BODY_FORCE_Y,0) = -9.810000; -NODES[2763](BODY_FORCE_Z,0) = 0.000000; -NODES[2764](BODY_FORCE_X,0) = 0.000000; -NODES[2764](BODY_FORCE_Y,0) = -9.810000; -NODES[2764](BODY_FORCE_Z,0) = 0.000000; -NODES[2765](BODY_FORCE_X,0) = 0.000000; -NODES[2765](BODY_FORCE_Y,0) = -9.810000; -NODES[2765](BODY_FORCE_Z,0) = 0.000000; -NODES[2766](BODY_FORCE_X,0) = 0.000000; -NODES[2766](BODY_FORCE_Y,0) = -9.810000; -NODES[2766](BODY_FORCE_Z,0) = 0.000000; -NODES[2767](BODY_FORCE_X,0) = 0.000000; -NODES[2767](BODY_FORCE_Y,0) = -9.810000; -NODES[2767](BODY_FORCE_Z,0) = 0.000000; -NODES[2768](BODY_FORCE_X,0) = 0.000000; -NODES[2768](BODY_FORCE_Y,0) = -9.810000; -NODES[2768](BODY_FORCE_Z,0) = 0.000000; -NODES[2769](BODY_FORCE_X,0) = 0.000000; -NODES[2769](BODY_FORCE_Y,0) = -9.810000; -NODES[2769](BODY_FORCE_Z,0) = 0.000000; -NODES[2770](BODY_FORCE_X,0) = 0.000000; -NODES[2770](BODY_FORCE_Y,0) = -9.810000; -NODES[2770](BODY_FORCE_Z,0) = 0.000000; -NODES[2771](BODY_FORCE_X,0) = 0.000000; -NODES[2771](BODY_FORCE_Y,0) = -9.810000; -NODES[2771](BODY_FORCE_Z,0) = 0.000000; -NODES[2772](BODY_FORCE_X,0) = 0.000000; -NODES[2772](BODY_FORCE_Y,0) = -9.810000; -NODES[2772](BODY_FORCE_Z,0) = 0.000000; -NODES[2773](BODY_FORCE_X,0) = 0.000000; -NODES[2773](BODY_FORCE_Y,0) = -9.810000; -NODES[2773](BODY_FORCE_Z,0) = 0.000000; -NODES[2774](BODY_FORCE_X,0) = 0.000000; -NODES[2774](BODY_FORCE_Y,0) = -9.810000; -NODES[2774](BODY_FORCE_Z,0) = 0.000000; -NODES[2775](BODY_FORCE_X,0) = 0.000000; -NODES[2775](BODY_FORCE_Y,0) = -9.810000; -NODES[2775](BODY_FORCE_Z,0) = 0.000000; -NODES[2776](BODY_FORCE_X,0) = 0.000000; -NODES[2776](BODY_FORCE_Y,0) = -9.810000; -NODES[2776](BODY_FORCE_Z,0) = 0.000000; -NODES[2777](BODY_FORCE_X,0) = 0.000000; -NODES[2777](BODY_FORCE_Y,0) = -9.810000; -NODES[2777](BODY_FORCE_Z,0) = 0.000000; -NODES[2778](BODY_FORCE_X,0) = 0.000000; -NODES[2778](BODY_FORCE_Y,0) = -9.810000; -NODES[2778](BODY_FORCE_Z,0) = 0.000000; -NODES[2779](BODY_FORCE_X,0) = 0.000000; -NODES[2779](BODY_FORCE_Y,0) = -9.810000; -NODES[2779](BODY_FORCE_Z,0) = 0.000000; -NODES[2780](BODY_FORCE_X,0) = 0.000000; -NODES[2780](BODY_FORCE_Y,0) = -9.810000; -NODES[2780](BODY_FORCE_Z,0) = 0.000000; -NODES[2781](BODY_FORCE_X,0) = 0.000000; -NODES[2781](BODY_FORCE_Y,0) = -9.810000; -NODES[2781](BODY_FORCE_Z,0) = 0.000000; -NODES[2782](BODY_FORCE_X,0) = 0.000000; -NODES[2782](BODY_FORCE_Y,0) = -9.810000; -NODES[2782](BODY_FORCE_Z,0) = 0.000000; -NODES[2783](BODY_FORCE_X,0) = 0.000000; -NODES[2783](BODY_FORCE_Y,0) = -9.810000; -NODES[2783](BODY_FORCE_Z,0) = 0.000000; -NODES[2784](BODY_FORCE_X,0) = 0.000000; -NODES[2784](BODY_FORCE_Y,0) = -9.810000; -NODES[2784](BODY_FORCE_Z,0) = 0.000000; -NODES[2785](BODY_FORCE_X,0) = 0.000000; -NODES[2785](BODY_FORCE_Y,0) = -9.810000; -NODES[2785](BODY_FORCE_Z,0) = 0.000000; -NODES[2786](BODY_FORCE_X,0) = 0.000000; -NODES[2786](BODY_FORCE_Y,0) = -9.810000; -NODES[2786](BODY_FORCE_Z,0) = 0.000000; -NODES[2787](BODY_FORCE_X,0) = 0.000000; -NODES[2787](BODY_FORCE_Y,0) = -9.810000; -NODES[2787](BODY_FORCE_Z,0) = 0.000000; -NODES[2789](BODY_FORCE_X,0) = 0.000000; -NODES[2789](BODY_FORCE_Y,0) = -9.810000; -NODES[2789](BODY_FORCE_Z,0) = 0.000000; -NODES[2790](BODY_FORCE_X,0) = 0.000000; -NODES[2790](BODY_FORCE_Y,0) = -9.810000; -NODES[2790](BODY_FORCE_Z,0) = 0.000000; -NODES[2791](BODY_FORCE_X,0) = 0.000000; -NODES[2791](BODY_FORCE_Y,0) = -9.810000; -NODES[2791](BODY_FORCE_Z,0) = 0.000000; -NODES[2792](BODY_FORCE_X,0) = 0.000000; -NODES[2792](BODY_FORCE_Y,0) = -9.810000; -NODES[2792](BODY_FORCE_Z,0) = 0.000000; -NODES[2793](BODY_FORCE_X,0) = 0.000000; -NODES[2793](BODY_FORCE_Y,0) = -9.810000; -NODES[2793](BODY_FORCE_Z,0) = 0.000000; -NODES[2794](BODY_FORCE_X,0) = 0.000000; -NODES[2794](BODY_FORCE_Y,0) = -9.810000; -NODES[2794](BODY_FORCE_Z,0) = 0.000000; -NODES[2795](BODY_FORCE_X,0) = 0.000000; -NODES[2795](BODY_FORCE_Y,0) = -9.810000; -NODES[2795](BODY_FORCE_Z,0) = 0.000000; -NODES[2796](BODY_FORCE_X,0) = 0.000000; -NODES[2796](BODY_FORCE_Y,0) = -9.810000; -NODES[2796](BODY_FORCE_Z,0) = 0.000000; -NODES[2797](BODY_FORCE_X,0) = 0.000000; -NODES[2797](BODY_FORCE_Y,0) = -9.810000; -NODES[2797](BODY_FORCE_Z,0) = 0.000000; -NODES[2798](BODY_FORCE_X,0) = 0.000000; -NODES[2798](BODY_FORCE_Y,0) = -9.810000; -NODES[2798](BODY_FORCE_Z,0) = 0.000000; -NODES[2799](BODY_FORCE_X,0) = 0.000000; -NODES[2799](BODY_FORCE_Y,0) = -9.810000; -NODES[2799](BODY_FORCE_Z,0) = 0.000000; -NODES[2800](BODY_FORCE_X,0) = 0.000000; -NODES[2800](BODY_FORCE_Y,0) = -9.810000; -NODES[2800](BODY_FORCE_Z,0) = 0.000000; -NODES[2801](BODY_FORCE_X,0) = 0.000000; -NODES[2801](BODY_FORCE_Y,0) = -9.810000; -NODES[2801](BODY_FORCE_Z,0) = 0.000000; -NODES[2802](BODY_FORCE_X,0) = 0.000000; -NODES[2802](BODY_FORCE_Y,0) = -9.810000; -NODES[2802](BODY_FORCE_Z,0) = 0.000000; -NODES[2803](BODY_FORCE_X,0) = 0.000000; -NODES[2803](BODY_FORCE_Y,0) = -9.810000; -NODES[2803](BODY_FORCE_Z,0) = 0.000000; -NODES[2804](BODY_FORCE_X,0) = 0.000000; -NODES[2804](BODY_FORCE_Y,0) = -9.810000; -NODES[2804](BODY_FORCE_Z,0) = 0.000000; -NODES[2805](BODY_FORCE_X,0) = 0.000000; -NODES[2805](BODY_FORCE_Y,0) = -9.810000; -NODES[2805](BODY_FORCE_Z,0) = 0.000000; -NODES[2806](BODY_FORCE_X,0) = 0.000000; -NODES[2806](BODY_FORCE_Y,0) = -9.810000; -NODES[2806](BODY_FORCE_Z,0) = 0.000000; -NODES[2807](BODY_FORCE_X,0) = 0.000000; -NODES[2807](BODY_FORCE_Y,0) = -9.810000; -NODES[2807](BODY_FORCE_Z,0) = 0.000000; -NODES[2808](BODY_FORCE_X,0) = 0.000000; -NODES[2808](BODY_FORCE_Y,0) = -9.810000; -NODES[2808](BODY_FORCE_Z,0) = 0.000000; -NODES[2809](BODY_FORCE_X,0) = 0.000000; -NODES[2809](BODY_FORCE_Y,0) = -9.810000; -NODES[2809](BODY_FORCE_Z,0) = 0.000000; -NODES[2810](BODY_FORCE_X,0) = 0.000000; -NODES[2810](BODY_FORCE_Y,0) = -9.810000; -NODES[2810](BODY_FORCE_Z,0) = 0.000000; -NODES[2811](BODY_FORCE_X,0) = 0.000000; -NODES[2811](BODY_FORCE_Y,0) = -9.810000; -NODES[2811](BODY_FORCE_Z,0) = 0.000000; -NODES[2812](BODY_FORCE_X,0) = 0.000000; -NODES[2812](BODY_FORCE_Y,0) = -9.810000; -NODES[2812](BODY_FORCE_Z,0) = 0.000000; -NODES[2813](BODY_FORCE_X,0) = 0.000000; -NODES[2813](BODY_FORCE_Y,0) = -9.810000; -NODES[2813](BODY_FORCE_Z,0) = 0.000000; -NODES[2814](BODY_FORCE_X,0) = 0.000000; -NODES[2814](BODY_FORCE_Y,0) = -9.810000; -NODES[2814](BODY_FORCE_Z,0) = 0.000000; -NODES[2815](BODY_FORCE_X,0) = 0.000000; -NODES[2815](BODY_FORCE_Y,0) = -9.810000; -NODES[2815](BODY_FORCE_Z,0) = 0.000000; -NODES[2816](BODY_FORCE_X,0) = 0.000000; -NODES[2816](BODY_FORCE_Y,0) = -9.810000; -NODES[2816](BODY_FORCE_Z,0) = 0.000000; -NODES[2818](BODY_FORCE_X,0) = 0.000000; -NODES[2818](BODY_FORCE_Y,0) = -9.810000; -NODES[2818](BODY_FORCE_Z,0) = 0.000000; -NODES[2819](BODY_FORCE_X,0) = 0.000000; -NODES[2819](BODY_FORCE_Y,0) = -9.810000; -NODES[2819](BODY_FORCE_Z,0) = 0.000000; -NODES[2820](BODY_FORCE_X,0) = 0.000000; -NODES[2820](BODY_FORCE_Y,0) = -9.810000; -NODES[2820](BODY_FORCE_Z,0) = 0.000000; -NODES[2821](BODY_FORCE_X,0) = 0.000000; -NODES[2821](BODY_FORCE_Y,0) = -9.810000; -NODES[2821](BODY_FORCE_Z,0) = 0.000000; -NODES[2822](BODY_FORCE_X,0) = 0.000000; -NODES[2822](BODY_FORCE_Y,0) = -9.810000; -NODES[2822](BODY_FORCE_Z,0) = 0.000000; -NODES[2823](BODY_FORCE_X,0) = 0.000000; -NODES[2823](BODY_FORCE_Y,0) = -9.810000; -NODES[2823](BODY_FORCE_Z,0) = 0.000000; -NODES[2824](BODY_FORCE_X,0) = 0.000000; -NODES[2824](BODY_FORCE_Y,0) = -9.810000; -NODES[2824](BODY_FORCE_Z,0) = 0.000000; -NODES[2825](BODY_FORCE_X,0) = 0.000000; -NODES[2825](BODY_FORCE_Y,0) = -9.810000; -NODES[2825](BODY_FORCE_Z,0) = 0.000000; -NODES[2826](BODY_FORCE_X,0) = 0.000000; -NODES[2826](BODY_FORCE_Y,0) = -9.810000; -NODES[2826](BODY_FORCE_Z,0) = 0.000000; -NODES[2827](BODY_FORCE_X,0) = 0.000000; -NODES[2827](BODY_FORCE_Y,0) = -9.810000; -NODES[2827](BODY_FORCE_Z,0) = 0.000000; -NODES[2828](BODY_FORCE_X,0) = 0.000000; -NODES[2828](BODY_FORCE_Y,0) = -9.810000; -NODES[2828](BODY_FORCE_Z,0) = 0.000000; -NODES[2829](BODY_FORCE_X,0) = 0.000000; -NODES[2829](BODY_FORCE_Y,0) = -9.810000; -NODES[2829](BODY_FORCE_Z,0) = 0.000000; -NODES[2830](BODY_FORCE_X,0) = 0.000000; -NODES[2830](BODY_FORCE_Y,0) = -9.810000; -NODES[2830](BODY_FORCE_Z,0) = 0.000000; -NODES[2831](BODY_FORCE_X,0) = 0.000000; -NODES[2831](BODY_FORCE_Y,0) = -9.810000; -NODES[2831](BODY_FORCE_Z,0) = 0.000000; -NODES[2832](BODY_FORCE_X,0) = 0.000000; -NODES[2832](BODY_FORCE_Y,0) = -9.810000; -NODES[2832](BODY_FORCE_Z,0) = 0.000000; -NODES[2833](BODY_FORCE_X,0) = 0.000000; -NODES[2833](BODY_FORCE_Y,0) = -9.810000; -NODES[2833](BODY_FORCE_Z,0) = 0.000000; -NODES[2834](BODY_FORCE_X,0) = 0.000000; -NODES[2834](BODY_FORCE_Y,0) = -9.810000; -NODES[2834](BODY_FORCE_Z,0) = 0.000000; -NODES[2835](BODY_FORCE_X,0) = 0.000000; -NODES[2835](BODY_FORCE_Y,0) = -9.810000; -NODES[2835](BODY_FORCE_Z,0) = 0.000000; -NODES[2836](BODY_FORCE_X,0) = 0.000000; -NODES[2836](BODY_FORCE_Y,0) = -9.810000; -NODES[2836](BODY_FORCE_Z,0) = 0.000000; -NODES[2837](BODY_FORCE_X,0) = 0.000000; -NODES[2837](BODY_FORCE_Y,0) = -9.810000; -NODES[2837](BODY_FORCE_Z,0) = 0.000000; -NODES[2838](BODY_FORCE_X,0) = 0.000000; -NODES[2838](BODY_FORCE_Y,0) = -9.810000; -NODES[2838](BODY_FORCE_Z,0) = 0.000000; -NODES[2839](BODY_FORCE_X,0) = 0.000000; -NODES[2839](BODY_FORCE_Y,0) = -9.810000; -NODES[2839](BODY_FORCE_Z,0) = 0.000000; -NODES[2840](BODY_FORCE_X,0) = 0.000000; -NODES[2840](BODY_FORCE_Y,0) = -9.810000; -NODES[2840](BODY_FORCE_Z,0) = 0.000000; -NODES[2841](BODY_FORCE_X,0) = 0.000000; -NODES[2841](BODY_FORCE_Y,0) = -9.810000; -NODES[2841](BODY_FORCE_Z,0) = 0.000000; -NODES[2842](BODY_FORCE_X,0) = 0.000000; -NODES[2842](BODY_FORCE_Y,0) = -9.810000; -NODES[2842](BODY_FORCE_Z,0) = 0.000000; -NODES[2843](BODY_FORCE_X,0) = 0.000000; -NODES[2843](BODY_FORCE_Y,0) = -9.810000; -NODES[2843](BODY_FORCE_Z,0) = 0.000000; -NODES[2844](BODY_FORCE_X,0) = 0.000000; -NODES[2844](BODY_FORCE_Y,0) = -9.810000; -NODES[2844](BODY_FORCE_Z,0) = 0.000000; -NODES[2845](BODY_FORCE_X,0) = 0.000000; -NODES[2845](BODY_FORCE_Y,0) = -9.810000; -NODES[2845](BODY_FORCE_Z,0) = 0.000000; -NODES[2846](BODY_FORCE_X,0) = 0.000000; -NODES[2846](BODY_FORCE_Y,0) = -9.810000; -NODES[2846](BODY_FORCE_Z,0) = 0.000000; -NODES[2847](BODY_FORCE_X,0) = 0.000000; -NODES[2847](BODY_FORCE_Y,0) = -9.810000; -NODES[2847](BODY_FORCE_Z,0) = 0.000000; -NODES[2849](BODY_FORCE_X,0) = 0.000000; -NODES[2849](BODY_FORCE_Y,0) = -9.810000; -NODES[2849](BODY_FORCE_Z,0) = 0.000000; -NODES[2850](BODY_FORCE_X,0) = 0.000000; -NODES[2850](BODY_FORCE_Y,0) = -9.810000; -NODES[2850](BODY_FORCE_Z,0) = 0.000000; -NODES[2851](BODY_FORCE_X,0) = 0.000000; -NODES[2851](BODY_FORCE_Y,0) = -9.810000; -NODES[2851](BODY_FORCE_Z,0) = 0.000000; -NODES[2852](BODY_FORCE_X,0) = 0.000000; -NODES[2852](BODY_FORCE_Y,0) = -9.810000; -NODES[2852](BODY_FORCE_Z,0) = 0.000000; -NODES[2853](BODY_FORCE_X,0) = 0.000000; -NODES[2853](BODY_FORCE_Y,0) = -9.810000; -NODES[2853](BODY_FORCE_Z,0) = 0.000000; -NODES[2854](BODY_FORCE_X,0) = 0.000000; -NODES[2854](BODY_FORCE_Y,0) = -9.810000; -NODES[2854](BODY_FORCE_Z,0) = 0.000000; -NODES[2855](BODY_FORCE_X,0) = 0.000000; -NODES[2855](BODY_FORCE_Y,0) = -9.810000; -NODES[2855](BODY_FORCE_Z,0) = 0.000000; -NODES[2856](BODY_FORCE_X,0) = 0.000000; -NODES[2856](BODY_FORCE_Y,0) = -9.810000; -NODES[2856](BODY_FORCE_Z,0) = 0.000000; -NODES[2857](BODY_FORCE_X,0) = 0.000000; -NODES[2857](BODY_FORCE_Y,0) = -9.810000; -NODES[2857](BODY_FORCE_Z,0) = 0.000000; -NODES[2858](BODY_FORCE_X,0) = 0.000000; -NODES[2858](BODY_FORCE_Y,0) = -9.810000; -NODES[2858](BODY_FORCE_Z,0) = 0.000000; -NODES[2859](BODY_FORCE_X,0) = 0.000000; -NODES[2859](BODY_FORCE_Y,0) = -9.810000; -NODES[2859](BODY_FORCE_Z,0) = 0.000000; -NODES[2860](BODY_FORCE_X,0) = 0.000000; -NODES[2860](BODY_FORCE_Y,0) = -9.810000; -NODES[2860](BODY_FORCE_Z,0) = 0.000000; -NODES[2861](BODY_FORCE_X,0) = 0.000000; -NODES[2861](BODY_FORCE_Y,0) = -9.810000; -NODES[2861](BODY_FORCE_Z,0) = 0.000000; -NODES[2862](BODY_FORCE_X,0) = 0.000000; -NODES[2862](BODY_FORCE_Y,0) = -9.810000; -NODES[2862](BODY_FORCE_Z,0) = 0.000000; -NODES[2863](BODY_FORCE_X,0) = 0.000000; -NODES[2863](BODY_FORCE_Y,0) = -9.810000; -NODES[2863](BODY_FORCE_Z,0) = 0.000000; -NODES[2864](BODY_FORCE_X,0) = 0.000000; -NODES[2864](BODY_FORCE_Y,0) = -9.810000; -NODES[2864](BODY_FORCE_Z,0) = 0.000000; -NODES[2865](BODY_FORCE_X,0) = 0.000000; -NODES[2865](BODY_FORCE_Y,0) = -9.810000; -NODES[2865](BODY_FORCE_Z,0) = 0.000000; -NODES[2866](BODY_FORCE_X,0) = 0.000000; -NODES[2866](BODY_FORCE_Y,0) = -9.810000; -NODES[2866](BODY_FORCE_Z,0) = 0.000000; -NODES[2867](BODY_FORCE_X,0) = 0.000000; -NODES[2867](BODY_FORCE_Y,0) = -9.810000; -NODES[2867](BODY_FORCE_Z,0) = 0.000000; -NODES[2868](BODY_FORCE_X,0) = 0.000000; -NODES[2868](BODY_FORCE_Y,0) = -9.810000; -NODES[2868](BODY_FORCE_Z,0) = 0.000000; -NODES[2869](BODY_FORCE_X,0) = 0.000000; -NODES[2869](BODY_FORCE_Y,0) = -9.810000; -NODES[2869](BODY_FORCE_Z,0) = 0.000000; -NODES[2870](BODY_FORCE_X,0) = 0.000000; -NODES[2870](BODY_FORCE_Y,0) = -9.810000; -NODES[2870](BODY_FORCE_Z,0) = 0.000000; -NODES[2871](BODY_FORCE_X,0) = 0.000000; -NODES[2871](BODY_FORCE_Y,0) = -9.810000; -NODES[2871](BODY_FORCE_Z,0) = 0.000000; -NODES[2872](BODY_FORCE_X,0) = 0.000000; -NODES[2872](BODY_FORCE_Y,0) = -9.810000; -NODES[2872](BODY_FORCE_Z,0) = 0.000000; -NODES[2873](BODY_FORCE_X,0) = 0.000000; -NODES[2873](BODY_FORCE_Y,0) = -9.810000; -NODES[2873](BODY_FORCE_Z,0) = 0.000000; -NODES[2874](BODY_FORCE_X,0) = 0.000000; -NODES[2874](BODY_FORCE_Y,0) = -9.810000; -NODES[2874](BODY_FORCE_Z,0) = 0.000000; -NODES[2875](BODY_FORCE_X,0) = 0.000000; -NODES[2875](BODY_FORCE_Y,0) = -9.810000; -NODES[2875](BODY_FORCE_Z,0) = 0.000000; -NODES[2876](BODY_FORCE_X,0) = 0.000000; -NODES[2876](BODY_FORCE_Y,0) = -9.810000; -NODES[2876](BODY_FORCE_Z,0) = 0.000000; -NODES[2877](BODY_FORCE_X,0) = 0.000000; -NODES[2877](BODY_FORCE_Y,0) = -9.810000; -NODES[2877](BODY_FORCE_Z,0) = 0.000000; -NODES[2879](BODY_FORCE_X,0) = 0.000000; -NODES[2879](BODY_FORCE_Y,0) = -9.810000; -NODES[2879](BODY_FORCE_Z,0) = 0.000000; -NODES[2880](BODY_FORCE_X,0) = 0.000000; -NODES[2880](BODY_FORCE_Y,0) = -9.810000; -NODES[2880](BODY_FORCE_Z,0) = 0.000000; -NODES[2881](BODY_FORCE_X,0) = 0.000000; -NODES[2881](BODY_FORCE_Y,0) = -9.810000; -NODES[2881](BODY_FORCE_Z,0) = 0.000000; -NODES[2882](BODY_FORCE_X,0) = 0.000000; -NODES[2882](BODY_FORCE_Y,0) = -9.810000; -NODES[2882](BODY_FORCE_Z,0) = 0.000000; -NODES[2883](BODY_FORCE_X,0) = 0.000000; -NODES[2883](BODY_FORCE_Y,0) = -9.810000; -NODES[2883](BODY_FORCE_Z,0) = 0.000000; -NODES[2884](BODY_FORCE_X,0) = 0.000000; -NODES[2884](BODY_FORCE_Y,0) = -9.810000; -NODES[2884](BODY_FORCE_Z,0) = 0.000000; -NODES[2885](BODY_FORCE_X,0) = 0.000000; -NODES[2885](BODY_FORCE_Y,0) = -9.810000; -NODES[2885](BODY_FORCE_Z,0) = 0.000000; -NODES[2886](BODY_FORCE_X,0) = 0.000000; -NODES[2886](BODY_FORCE_Y,0) = -9.810000; -NODES[2886](BODY_FORCE_Z,0) = 0.000000; -NODES[2887](BODY_FORCE_X,0) = 0.000000; -NODES[2887](BODY_FORCE_Y,0) = -9.810000; -NODES[2887](BODY_FORCE_Z,0) = 0.000000; -NODES[2888](BODY_FORCE_X,0) = 0.000000; -NODES[2888](BODY_FORCE_Y,0) = -9.810000; -NODES[2888](BODY_FORCE_Z,0) = 0.000000; -NODES[2889](BODY_FORCE_X,0) = 0.000000; -NODES[2889](BODY_FORCE_Y,0) = -9.810000; -NODES[2889](BODY_FORCE_Z,0) = 0.000000; -NODES[2890](BODY_FORCE_X,0) = 0.000000; -NODES[2890](BODY_FORCE_Y,0) = -9.810000; -NODES[2890](BODY_FORCE_Z,0) = 0.000000; -NODES[2891](BODY_FORCE_X,0) = 0.000000; -NODES[2891](BODY_FORCE_Y,0) = -9.810000; -NODES[2891](BODY_FORCE_Z,0) = 0.000000; -NODES[2892](BODY_FORCE_X,0) = 0.000000; -NODES[2892](BODY_FORCE_Y,0) = -9.810000; -NODES[2892](BODY_FORCE_Z,0) = 0.000000; -NODES[2893](BODY_FORCE_X,0) = 0.000000; -NODES[2893](BODY_FORCE_Y,0) = -9.810000; -NODES[2893](BODY_FORCE_Z,0) = 0.000000; -NODES[2894](BODY_FORCE_X,0) = 0.000000; -NODES[2894](BODY_FORCE_Y,0) = -9.810000; -NODES[2894](BODY_FORCE_Z,0) = 0.000000; -NODES[2895](BODY_FORCE_X,0) = 0.000000; -NODES[2895](BODY_FORCE_Y,0) = -9.810000; -NODES[2895](BODY_FORCE_Z,0) = 0.000000; -NODES[2896](BODY_FORCE_X,0) = 0.000000; -NODES[2896](BODY_FORCE_Y,0) = -9.810000; -NODES[2896](BODY_FORCE_Z,0) = 0.000000; -NODES[2897](BODY_FORCE_X,0) = 0.000000; -NODES[2897](BODY_FORCE_Y,0) = -9.810000; -NODES[2897](BODY_FORCE_Z,0) = 0.000000; -NODES[2898](BODY_FORCE_X,0) = 0.000000; -NODES[2898](BODY_FORCE_Y,0) = -9.810000; -NODES[2898](BODY_FORCE_Z,0) = 0.000000; -NODES[2899](BODY_FORCE_X,0) = 0.000000; -NODES[2899](BODY_FORCE_Y,0) = -9.810000; -NODES[2899](BODY_FORCE_Z,0) = 0.000000; -NODES[2900](BODY_FORCE_X,0) = 0.000000; -NODES[2900](BODY_FORCE_Y,0) = -9.810000; -NODES[2900](BODY_FORCE_Z,0) = 0.000000; -NODES[2901](BODY_FORCE_X,0) = 0.000000; -NODES[2901](BODY_FORCE_Y,0) = -9.810000; -NODES[2901](BODY_FORCE_Z,0) = 0.000000; -NODES[2902](BODY_FORCE_X,0) = 0.000000; -NODES[2902](BODY_FORCE_Y,0) = -9.810000; -NODES[2902](BODY_FORCE_Z,0) = 0.000000; -NODES[2903](BODY_FORCE_X,0) = 0.000000; -NODES[2903](BODY_FORCE_Y,0) = -9.810000; -NODES[2903](BODY_FORCE_Z,0) = 0.000000; -NODES[2904](BODY_FORCE_X,0) = 0.000000; -NODES[2904](BODY_FORCE_Y,0) = -9.810000; -NODES[2904](BODY_FORCE_Z,0) = 0.000000; -NODES[2906](BODY_FORCE_X,0) = 0.000000; -NODES[2906](BODY_FORCE_Y,0) = -9.810000; -NODES[2906](BODY_FORCE_Z,0) = 0.000000; -NODES[2907](BODY_FORCE_X,0) = 0.000000; -NODES[2907](BODY_FORCE_Y,0) = -9.810000; -NODES[2907](BODY_FORCE_Z,0) = 0.000000; -NODES[2908](BODY_FORCE_X,0) = 0.000000; -NODES[2908](BODY_FORCE_Y,0) = -9.810000; -NODES[2908](BODY_FORCE_Z,0) = 0.000000; -NODES[2909](BODY_FORCE_X,0) = 0.000000; -NODES[2909](BODY_FORCE_Y,0) = -9.810000; -NODES[2909](BODY_FORCE_Z,0) = 0.000000; -NODES[2910](BODY_FORCE_X,0) = 0.000000; -NODES[2910](BODY_FORCE_Y,0) = -9.810000; -NODES[2910](BODY_FORCE_Z,0) = 0.000000; -NODES[2911](BODY_FORCE_X,0) = 0.000000; -NODES[2911](BODY_FORCE_Y,0) = -9.810000; -NODES[2911](BODY_FORCE_Z,0) = 0.000000; -NODES[2912](BODY_FORCE_X,0) = 0.000000; -NODES[2912](BODY_FORCE_Y,0) = -9.810000; -NODES[2912](BODY_FORCE_Z,0) = 0.000000; -NODES[2913](BODY_FORCE_X,0) = 0.000000; -NODES[2913](BODY_FORCE_Y,0) = -9.810000; -NODES[2913](BODY_FORCE_Z,0) = 0.000000; -NODES[2914](BODY_FORCE_X,0) = 0.000000; -NODES[2914](BODY_FORCE_Y,0) = -9.810000; -NODES[2914](BODY_FORCE_Z,0) = 0.000000; -NODES[2915](BODY_FORCE_X,0) = 0.000000; -NODES[2915](BODY_FORCE_Y,0) = -9.810000; -NODES[2915](BODY_FORCE_Z,0) = 0.000000; -NODES[2916](BODY_FORCE_X,0) = 0.000000; -NODES[2916](BODY_FORCE_Y,0) = -9.810000; -NODES[2916](BODY_FORCE_Z,0) = 0.000000; -NODES[2917](BODY_FORCE_X,0) = 0.000000; -NODES[2917](BODY_FORCE_Y,0) = -9.810000; -NODES[2917](BODY_FORCE_Z,0) = 0.000000; -NODES[2918](BODY_FORCE_X,0) = 0.000000; -NODES[2918](BODY_FORCE_Y,0) = -9.810000; -NODES[2918](BODY_FORCE_Z,0) = 0.000000; -NODES[2919](BODY_FORCE_X,0) = 0.000000; -NODES[2919](BODY_FORCE_Y,0) = -9.810000; -NODES[2919](BODY_FORCE_Z,0) = 0.000000; -NODES[2920](BODY_FORCE_X,0) = 0.000000; -NODES[2920](BODY_FORCE_Y,0) = -9.810000; -NODES[2920](BODY_FORCE_Z,0) = 0.000000; -NODES[2921](BODY_FORCE_X,0) = 0.000000; -NODES[2921](BODY_FORCE_Y,0) = -9.810000; -NODES[2921](BODY_FORCE_Z,0) = 0.000000; -NODES[2922](BODY_FORCE_X,0) = 0.000000; -NODES[2922](BODY_FORCE_Y,0) = -9.810000; -NODES[2922](BODY_FORCE_Z,0) = 0.000000; -NODES[2923](BODY_FORCE_X,0) = 0.000000; -NODES[2923](BODY_FORCE_Y,0) = -9.810000; -NODES[2923](BODY_FORCE_Z,0) = 0.000000; -NODES[2924](BODY_FORCE_X,0) = 0.000000; -NODES[2924](BODY_FORCE_Y,0) = -9.810000; -NODES[2924](BODY_FORCE_Z,0) = 0.000000; -NODES[2925](BODY_FORCE_X,0) = 0.000000; -NODES[2925](BODY_FORCE_Y,0) = -9.810000; -NODES[2925](BODY_FORCE_Z,0) = 0.000000; -NODES[2926](BODY_FORCE_X,0) = 0.000000; -NODES[2926](BODY_FORCE_Y,0) = -9.810000; -NODES[2926](BODY_FORCE_Z,0) = 0.000000; -NODES[2927](BODY_FORCE_X,0) = 0.000000; -NODES[2927](BODY_FORCE_Y,0) = -9.810000; -NODES[2927](BODY_FORCE_Z,0) = 0.000000; -NODES[2928](BODY_FORCE_X,0) = 0.000000; -NODES[2928](BODY_FORCE_Y,0) = -9.810000; -NODES[2928](BODY_FORCE_Z,0) = 0.000000; -NODES[2929](BODY_FORCE_X,0) = 0.000000; -NODES[2929](BODY_FORCE_Y,0) = -9.810000; -NODES[2929](BODY_FORCE_Z,0) = 0.000000; -NODES[2930](BODY_FORCE_X,0) = 0.000000; -NODES[2930](BODY_FORCE_Y,0) = -9.810000; -NODES[2930](BODY_FORCE_Z,0) = 0.000000; -NODES[2931](BODY_FORCE_X,0) = 0.000000; -NODES[2931](BODY_FORCE_Y,0) = -9.810000; -NODES[2931](BODY_FORCE_Z,0) = 0.000000; -NODES[2933](BODY_FORCE_X,0) = 0.000000; -NODES[2933](BODY_FORCE_Y,0) = -9.810000; -NODES[2933](BODY_FORCE_Z,0) = 0.000000; -NODES[2934](BODY_FORCE_X,0) = 0.000000; -NODES[2934](BODY_FORCE_Y,0) = -9.810000; -NODES[2934](BODY_FORCE_Z,0) = 0.000000; -NODES[2935](BODY_FORCE_X,0) = 0.000000; -NODES[2935](BODY_FORCE_Y,0) = -9.810000; -NODES[2935](BODY_FORCE_Z,0) = 0.000000; -NODES[2936](BODY_FORCE_X,0) = 0.000000; -NODES[2936](BODY_FORCE_Y,0) = -9.810000; -NODES[2936](BODY_FORCE_Z,0) = 0.000000; -NODES[2937](BODY_FORCE_X,0) = 0.000000; -NODES[2937](BODY_FORCE_Y,0) = -9.810000; -NODES[2937](BODY_FORCE_Z,0) = 0.000000; -NODES[2938](BODY_FORCE_X,0) = 0.000000; -NODES[2938](BODY_FORCE_Y,0) = -9.810000; -NODES[2938](BODY_FORCE_Z,0) = 0.000000; -NODES[2939](BODY_FORCE_X,0) = 0.000000; -NODES[2939](BODY_FORCE_Y,0) = -9.810000; -NODES[2939](BODY_FORCE_Z,0) = 0.000000; -NODES[2940](BODY_FORCE_X,0) = 0.000000; -NODES[2940](BODY_FORCE_Y,0) = -9.810000; -NODES[2940](BODY_FORCE_Z,0) = 0.000000; -NODES[2941](BODY_FORCE_X,0) = 0.000000; -NODES[2941](BODY_FORCE_Y,0) = -9.810000; -NODES[2941](BODY_FORCE_Z,0) = 0.000000; -NODES[2942](BODY_FORCE_X,0) = 0.000000; -NODES[2942](BODY_FORCE_Y,0) = -9.810000; -NODES[2942](BODY_FORCE_Z,0) = 0.000000; -NODES[2943](BODY_FORCE_X,0) = 0.000000; -NODES[2943](BODY_FORCE_Y,0) = -9.810000; -NODES[2943](BODY_FORCE_Z,0) = 0.000000; -NODES[2944](BODY_FORCE_X,0) = 0.000000; -NODES[2944](BODY_FORCE_Y,0) = -9.810000; -NODES[2944](BODY_FORCE_Z,0) = 0.000000; -NODES[2945](BODY_FORCE_X,0) = 0.000000; -NODES[2945](BODY_FORCE_Y,0) = -9.810000; -NODES[2945](BODY_FORCE_Z,0) = 0.000000; -NODES[2946](BODY_FORCE_X,0) = 0.000000; -NODES[2946](BODY_FORCE_Y,0) = -9.810000; -NODES[2946](BODY_FORCE_Z,0) = 0.000000; -NODES[2947](BODY_FORCE_X,0) = 0.000000; -NODES[2947](BODY_FORCE_Y,0) = -9.810000; -NODES[2947](BODY_FORCE_Z,0) = 0.000000; -NODES[2948](BODY_FORCE_X,0) = 0.000000; -NODES[2948](BODY_FORCE_Y,0) = -9.810000; -NODES[2948](BODY_FORCE_Z,0) = 0.000000; -NODES[2949](BODY_FORCE_X,0) = 0.000000; -NODES[2949](BODY_FORCE_Y,0) = -9.810000; -NODES[2949](BODY_FORCE_Z,0) = 0.000000; -NODES[2950](BODY_FORCE_X,0) = 0.000000; -NODES[2950](BODY_FORCE_Y,0) = -9.810000; -NODES[2950](BODY_FORCE_Z,0) = 0.000000; -NODES[2951](BODY_FORCE_X,0) = 0.000000; -NODES[2951](BODY_FORCE_Y,0) = -9.810000; -NODES[2951](BODY_FORCE_Z,0) = 0.000000; -NODES[2952](BODY_FORCE_X,0) = 0.000000; -NODES[2952](BODY_FORCE_Y,0) = -9.810000; -NODES[2952](BODY_FORCE_Z,0) = 0.000000; -NODES[2953](BODY_FORCE_X,0) = 0.000000; -NODES[2953](BODY_FORCE_Y,0) = -9.810000; -NODES[2953](BODY_FORCE_Z,0) = 0.000000; -NODES[2954](BODY_FORCE_X,0) = 0.000000; -NODES[2954](BODY_FORCE_Y,0) = -9.810000; -NODES[2954](BODY_FORCE_Z,0) = 0.000000; -NODES[2955](BODY_FORCE_X,0) = 0.000000; -NODES[2955](BODY_FORCE_Y,0) = -9.810000; -NODES[2955](BODY_FORCE_Z,0) = 0.000000; -NODES[2956](BODY_FORCE_X,0) = 0.000000; -NODES[2956](BODY_FORCE_Y,0) = -9.810000; -NODES[2956](BODY_FORCE_Z,0) = 0.000000; -NODES[2957](BODY_FORCE_X,0) = 0.000000; -NODES[2957](BODY_FORCE_Y,0) = -9.810000; -NODES[2957](BODY_FORCE_Z,0) = 0.000000; -NODES[2958](BODY_FORCE_X,0) = 0.000000; -NODES[2958](BODY_FORCE_Y,0) = -9.810000; -NODES[2958](BODY_FORCE_Z,0) = 0.000000; -NODES[2959](BODY_FORCE_X,0) = 0.000000; -NODES[2959](BODY_FORCE_Y,0) = -9.810000; -NODES[2959](BODY_FORCE_Z,0) = 0.000000; -NODES[2960](BODY_FORCE_X,0) = 0.000000; -NODES[2960](BODY_FORCE_Y,0) = -9.810000; -NODES[2960](BODY_FORCE_Z,0) = 0.000000; -NODES[2961](BODY_FORCE_X,0) = 0.000000; -NODES[2961](BODY_FORCE_Y,0) = -9.810000; -NODES[2961](BODY_FORCE_Z,0) = 0.000000; -NODES[2963](BODY_FORCE_X,0) = 0.000000; -NODES[2963](BODY_FORCE_Y,0) = -9.810000; -NODES[2963](BODY_FORCE_Z,0) = 0.000000; -NODES[2964](BODY_FORCE_X,0) = 0.000000; -NODES[2964](BODY_FORCE_Y,0) = -9.810000; -NODES[2964](BODY_FORCE_Z,0) = 0.000000; -NODES[2965](BODY_FORCE_X,0) = 0.000000; -NODES[2965](BODY_FORCE_Y,0) = -9.810000; -NODES[2965](BODY_FORCE_Z,0) = 0.000000; -NODES[2966](BODY_FORCE_X,0) = 0.000000; -NODES[2966](BODY_FORCE_Y,0) = -9.810000; -NODES[2966](BODY_FORCE_Z,0) = 0.000000; -NODES[2967](BODY_FORCE_X,0) = 0.000000; -NODES[2967](BODY_FORCE_Y,0) = -9.810000; -NODES[2967](BODY_FORCE_Z,0) = 0.000000; -NODES[2968](BODY_FORCE_X,0) = 0.000000; -NODES[2968](BODY_FORCE_Y,0) = -9.810000; -NODES[2968](BODY_FORCE_Z,0) = 0.000000; -NODES[2969](BODY_FORCE_X,0) = 0.000000; -NODES[2969](BODY_FORCE_Y,0) = -9.810000; -NODES[2969](BODY_FORCE_Z,0) = 0.000000; -NODES[2970](BODY_FORCE_X,0) = 0.000000; -NODES[2970](BODY_FORCE_Y,0) = -9.810000; -NODES[2970](BODY_FORCE_Z,0) = 0.000000; -NODES[2971](BODY_FORCE_X,0) = 0.000000; -NODES[2971](BODY_FORCE_Y,0) = -9.810000; -NODES[2971](BODY_FORCE_Z,0) = 0.000000; -NODES[2972](BODY_FORCE_X,0) = 0.000000; -NODES[2972](BODY_FORCE_Y,0) = -9.810000; -NODES[2972](BODY_FORCE_Z,0) = 0.000000; -NODES[2973](BODY_FORCE_X,0) = 0.000000; -NODES[2973](BODY_FORCE_Y,0) = -9.810000; -NODES[2973](BODY_FORCE_Z,0) = 0.000000; -NODES[2974](BODY_FORCE_X,0) = 0.000000; -NODES[2974](BODY_FORCE_Y,0) = -9.810000; -NODES[2974](BODY_FORCE_Z,0) = 0.000000; -NODES[2975](BODY_FORCE_X,0) = 0.000000; -NODES[2975](BODY_FORCE_Y,0) = -9.810000; -NODES[2975](BODY_FORCE_Z,0) = 0.000000; -NODES[2976](BODY_FORCE_X,0) = 0.000000; -NODES[2976](BODY_FORCE_Y,0) = -9.810000; -NODES[2976](BODY_FORCE_Z,0) = 0.000000; -NODES[2977](BODY_FORCE_X,0) = 0.000000; -NODES[2977](BODY_FORCE_Y,0) = -9.810000; -NODES[2977](BODY_FORCE_Z,0) = 0.000000; -NODES[2978](BODY_FORCE_X,0) = 0.000000; -NODES[2978](BODY_FORCE_Y,0) = -9.810000; -NODES[2978](BODY_FORCE_Z,0) = 0.000000; -NODES[2979](BODY_FORCE_X,0) = 0.000000; -NODES[2979](BODY_FORCE_Y,0) = -9.810000; -NODES[2979](BODY_FORCE_Z,0) = 0.000000; -NODES[2980](BODY_FORCE_X,0) = 0.000000; -NODES[2980](BODY_FORCE_Y,0) = -9.810000; -NODES[2980](BODY_FORCE_Z,0) = 0.000000; -NODES[2981](BODY_FORCE_X,0) = 0.000000; -NODES[2981](BODY_FORCE_Y,0) = -9.810000; -NODES[2981](BODY_FORCE_Z,0) = 0.000000; -NODES[2982](BODY_FORCE_X,0) = 0.000000; -NODES[2982](BODY_FORCE_Y,0) = -9.810000; -NODES[2982](BODY_FORCE_Z,0) = 0.000000; -NODES[2983](BODY_FORCE_X,0) = 0.000000; -NODES[2983](BODY_FORCE_Y,0) = -9.810000; -NODES[2983](BODY_FORCE_Z,0) = 0.000000; -NODES[2984](BODY_FORCE_X,0) = 0.000000; -NODES[2984](BODY_FORCE_Y,0) = -9.810000; -NODES[2984](BODY_FORCE_Z,0) = 0.000000; -NODES[2985](BODY_FORCE_X,0) = 0.000000; -NODES[2985](BODY_FORCE_Y,0) = -9.810000; -NODES[2985](BODY_FORCE_Z,0) = 0.000000; -NODES[2986](BODY_FORCE_X,0) = 0.000000; -NODES[2986](BODY_FORCE_Y,0) = -9.810000; -NODES[2986](BODY_FORCE_Z,0) = 0.000000; -NODES[2987](BODY_FORCE_X,0) = 0.000000; -NODES[2987](BODY_FORCE_Y,0) = -9.810000; -NODES[2987](BODY_FORCE_Z,0) = 0.000000; -NODES[2988](BODY_FORCE_X,0) = 0.000000; -NODES[2988](BODY_FORCE_Y,0) = -9.810000; -NODES[2988](BODY_FORCE_Z,0) = 0.000000; -NODES[2989](BODY_FORCE_X,0) = 0.000000; -NODES[2989](BODY_FORCE_Y,0) = -9.810000; -NODES[2989](BODY_FORCE_Z,0) = 0.000000; -NODES[2990](BODY_FORCE_X,0) = 0.000000; -NODES[2990](BODY_FORCE_Y,0) = -9.810000; -NODES[2990](BODY_FORCE_Z,0) = 0.000000; -NODES[2992](BODY_FORCE_X,0) = 0.000000; -NODES[2992](BODY_FORCE_Y,0) = -9.810000; -NODES[2992](BODY_FORCE_Z,0) = 0.000000; -NODES[2993](BODY_FORCE_X,0) = 0.000000; -NODES[2993](BODY_FORCE_Y,0) = -9.810000; -NODES[2993](BODY_FORCE_Z,0) = 0.000000; -NODES[2994](BODY_FORCE_X,0) = 0.000000; -NODES[2994](BODY_FORCE_Y,0) = -9.810000; -NODES[2994](BODY_FORCE_Z,0) = 0.000000; -NODES[2995](BODY_FORCE_X,0) = 0.000000; -NODES[2995](BODY_FORCE_Y,0) = -9.810000; -NODES[2995](BODY_FORCE_Z,0) = 0.000000; -NODES[2996](BODY_FORCE_X,0) = 0.000000; -NODES[2996](BODY_FORCE_Y,0) = -9.810000; -NODES[2996](BODY_FORCE_Z,0) = 0.000000; -NODES[2997](BODY_FORCE_X,0) = 0.000000; -NODES[2997](BODY_FORCE_Y,0) = -9.810000; -NODES[2997](BODY_FORCE_Z,0) = 0.000000; -NODES[2998](BODY_FORCE_X,0) = 0.000000; -NODES[2998](BODY_FORCE_Y,0) = -9.810000; -NODES[2998](BODY_FORCE_Z,0) = 0.000000; -NODES[2999](BODY_FORCE_X,0) = 0.000000; -NODES[2999](BODY_FORCE_Y,0) = -9.810000; -NODES[2999](BODY_FORCE_Z,0) = 0.000000; -NODES[3000](BODY_FORCE_X,0) = 0.000000; -NODES[3000](BODY_FORCE_Y,0) = -9.810000; -NODES[3000](BODY_FORCE_Z,0) = 0.000000; -NODES[3001](BODY_FORCE_X,0) = 0.000000; -NODES[3001](BODY_FORCE_Y,0) = -9.810000; -NODES[3001](BODY_FORCE_Z,0) = 0.000000; -NODES[3002](BODY_FORCE_X,0) = 0.000000; -NODES[3002](BODY_FORCE_Y,0) = -9.810000; -NODES[3002](BODY_FORCE_Z,0) = 0.000000; -NODES[3003](BODY_FORCE_X,0) = 0.000000; -NODES[3003](BODY_FORCE_Y,0) = -9.810000; -NODES[3003](BODY_FORCE_Z,0) = 0.000000; -NODES[3004](BODY_FORCE_X,0) = 0.000000; -NODES[3004](BODY_FORCE_Y,0) = -9.810000; -NODES[3004](BODY_FORCE_Z,0) = 0.000000; -NODES[3005](BODY_FORCE_X,0) = 0.000000; -NODES[3005](BODY_FORCE_Y,0) = -9.810000; -NODES[3005](BODY_FORCE_Z,0) = 0.000000; -NODES[3006](BODY_FORCE_X,0) = 0.000000; -NODES[3006](BODY_FORCE_Y,0) = -9.810000; -NODES[3006](BODY_FORCE_Z,0) = 0.000000; -NODES[3007](BODY_FORCE_X,0) = 0.000000; -NODES[3007](BODY_FORCE_Y,0) = -9.810000; -NODES[3007](BODY_FORCE_Z,0) = 0.000000; -NODES[3008](BODY_FORCE_X,0) = 0.000000; -NODES[3008](BODY_FORCE_Y,0) = -9.810000; -NODES[3008](BODY_FORCE_Z,0) = 0.000000; -NODES[3009](BODY_FORCE_X,0) = 0.000000; -NODES[3009](BODY_FORCE_Y,0) = -9.810000; -NODES[3009](BODY_FORCE_Z,0) = 0.000000; -NODES[3010](BODY_FORCE_X,0) = 0.000000; -NODES[3010](BODY_FORCE_Y,0) = -9.810000; -NODES[3010](BODY_FORCE_Z,0) = 0.000000; -NODES[3011](BODY_FORCE_X,0) = 0.000000; -NODES[3011](BODY_FORCE_Y,0) = -9.810000; -NODES[3011](BODY_FORCE_Z,0) = 0.000000; -NODES[3012](BODY_FORCE_X,0) = 0.000000; -NODES[3012](BODY_FORCE_Y,0) = -9.810000; -NODES[3012](BODY_FORCE_Z,0) = 0.000000; -NODES[3013](BODY_FORCE_X,0) = 0.000000; -NODES[3013](BODY_FORCE_Y,0) = -9.810000; -NODES[3013](BODY_FORCE_Z,0) = 0.000000; -NODES[3014](BODY_FORCE_X,0) = 0.000000; -NODES[3014](BODY_FORCE_Y,0) = -9.810000; -NODES[3014](BODY_FORCE_Z,0) = 0.000000; -NODES[3015](BODY_FORCE_X,0) = 0.000000; -NODES[3015](BODY_FORCE_Y,0) = -9.810000; -NODES[3015](BODY_FORCE_Z,0) = 0.000000; -NODES[3016](BODY_FORCE_X,0) = 0.000000; -NODES[3016](BODY_FORCE_Y,0) = -9.810000; -NODES[3016](BODY_FORCE_Z,0) = 0.000000; -NODES[3017](BODY_FORCE_X,0) = 0.000000; -NODES[3017](BODY_FORCE_Y,0) = -9.810000; -NODES[3017](BODY_FORCE_Z,0) = 0.000000; -NODES[3018](BODY_FORCE_X,0) = 0.000000; -NODES[3018](BODY_FORCE_Y,0) = -9.810000; -NODES[3018](BODY_FORCE_Z,0) = 0.000000; -NODES[3019](BODY_FORCE_X,0) = 0.000000; -NODES[3019](BODY_FORCE_Y,0) = -9.810000; -NODES[3019](BODY_FORCE_Z,0) = 0.000000; -NODES[3021](BODY_FORCE_X,0) = 0.000000; -NODES[3021](BODY_FORCE_Y,0) = -9.810000; -NODES[3021](BODY_FORCE_Z,0) = 0.000000; -NODES[3022](BODY_FORCE_X,0) = 0.000000; -NODES[3022](BODY_FORCE_Y,0) = -9.810000; -NODES[3022](BODY_FORCE_Z,0) = 0.000000; -NODES[3023](BODY_FORCE_X,0) = 0.000000; -NODES[3023](BODY_FORCE_Y,0) = -9.810000; -NODES[3023](BODY_FORCE_Z,0) = 0.000000; -NODES[3024](BODY_FORCE_X,0) = 0.000000; -NODES[3024](BODY_FORCE_Y,0) = -9.810000; -NODES[3024](BODY_FORCE_Z,0) = 0.000000; -NODES[3025](BODY_FORCE_X,0) = 0.000000; -NODES[3025](BODY_FORCE_Y,0) = -9.810000; -NODES[3025](BODY_FORCE_Z,0) = 0.000000; -NODES[3026](BODY_FORCE_X,0) = 0.000000; -NODES[3026](BODY_FORCE_Y,0) = -9.810000; -NODES[3026](BODY_FORCE_Z,0) = 0.000000; -NODES[3027](BODY_FORCE_X,0) = 0.000000; -NODES[3027](BODY_FORCE_Y,0) = -9.810000; -NODES[3027](BODY_FORCE_Z,0) = 0.000000; -NODES[3028](BODY_FORCE_X,0) = 0.000000; -NODES[3028](BODY_FORCE_Y,0) = -9.810000; -NODES[3028](BODY_FORCE_Z,0) = 0.000000; -NODES[3029](BODY_FORCE_X,0) = 0.000000; -NODES[3029](BODY_FORCE_Y,0) = -9.810000; -NODES[3029](BODY_FORCE_Z,0) = 0.000000; -NODES[3030](BODY_FORCE_X,0) = 0.000000; -NODES[3030](BODY_FORCE_Y,0) = -9.810000; -NODES[3030](BODY_FORCE_Z,0) = 0.000000; -NODES[3031](BODY_FORCE_X,0) = 0.000000; -NODES[3031](BODY_FORCE_Y,0) = -9.810000; -NODES[3031](BODY_FORCE_Z,0) = 0.000000; -NODES[3032](BODY_FORCE_X,0) = 0.000000; -NODES[3032](BODY_FORCE_Y,0) = -9.810000; -NODES[3032](BODY_FORCE_Z,0) = 0.000000; -NODES[3033](BODY_FORCE_X,0) = 0.000000; -NODES[3033](BODY_FORCE_Y,0) = -9.810000; -NODES[3033](BODY_FORCE_Z,0) = 0.000000; -NODES[3034](BODY_FORCE_X,0) = 0.000000; -NODES[3034](BODY_FORCE_Y,0) = -9.810000; -NODES[3034](BODY_FORCE_Z,0) = 0.000000; -NODES[3035](BODY_FORCE_X,0) = 0.000000; -NODES[3035](BODY_FORCE_Y,0) = -9.810000; -NODES[3035](BODY_FORCE_Z,0) = 0.000000; -NODES[3036](BODY_FORCE_X,0) = 0.000000; -NODES[3036](BODY_FORCE_Y,0) = -9.810000; -NODES[3036](BODY_FORCE_Z,0) = 0.000000; -NODES[3037](BODY_FORCE_X,0) = 0.000000; -NODES[3037](BODY_FORCE_Y,0) = -9.810000; -NODES[3037](BODY_FORCE_Z,0) = 0.000000; -NODES[3038](BODY_FORCE_X,0) = 0.000000; -NODES[3038](BODY_FORCE_Y,0) = -9.810000; -NODES[3038](BODY_FORCE_Z,0) = 0.000000; -NODES[3039](BODY_FORCE_X,0) = 0.000000; -NODES[3039](BODY_FORCE_Y,0) = -9.810000; -NODES[3039](BODY_FORCE_Z,0) = 0.000000; -NODES[3040](BODY_FORCE_X,0) = 0.000000; -NODES[3040](BODY_FORCE_Y,0) = -9.810000; -NODES[3040](BODY_FORCE_Z,0) = 0.000000; -NODES[3041](BODY_FORCE_X,0) = 0.000000; -NODES[3041](BODY_FORCE_Y,0) = -9.810000; -NODES[3041](BODY_FORCE_Z,0) = 0.000000; -NODES[3042](BODY_FORCE_X,0) = 0.000000; -NODES[3042](BODY_FORCE_Y,0) = -9.810000; -NODES[3042](BODY_FORCE_Z,0) = 0.000000; -NODES[3043](BODY_FORCE_X,0) = 0.000000; -NODES[3043](BODY_FORCE_Y,0) = -9.810000; -NODES[3043](BODY_FORCE_Z,0) = 0.000000; -NODES[3044](BODY_FORCE_X,0) = 0.000000; -NODES[3044](BODY_FORCE_Y,0) = -9.810000; -NODES[3044](BODY_FORCE_Z,0) = 0.000000; -NODES[3045](BODY_FORCE_X,0) = 0.000000; -NODES[3045](BODY_FORCE_Y,0) = -9.810000; -NODES[3045](BODY_FORCE_Z,0) = 0.000000; -NODES[3046](BODY_FORCE_X,0) = 0.000000; -NODES[3046](BODY_FORCE_Y,0) = -9.810000; -NODES[3046](BODY_FORCE_Z,0) = 0.000000; -NODES[3047](BODY_FORCE_X,0) = 0.000000; -NODES[3047](BODY_FORCE_Y,0) = -9.810000; -NODES[3047](BODY_FORCE_Z,0) = 0.000000; -NODES[3048](BODY_FORCE_X,0) = 0.000000; -NODES[3048](BODY_FORCE_Y,0) = -9.810000; -NODES[3048](BODY_FORCE_Z,0) = 0.000000; -NODES[3050](BODY_FORCE_X,0) = 0.000000; -NODES[3050](BODY_FORCE_Y,0) = -9.810000; -NODES[3050](BODY_FORCE_Z,0) = 0.000000; -NODES[3051](BODY_FORCE_X,0) = 0.000000; -NODES[3051](BODY_FORCE_Y,0) = -9.810000; -NODES[3051](BODY_FORCE_Z,0) = 0.000000; -NODES[3052](BODY_FORCE_X,0) = 0.000000; -NODES[3052](BODY_FORCE_Y,0) = -9.810000; -NODES[3052](BODY_FORCE_Z,0) = 0.000000; -NODES[3053](BODY_FORCE_X,0) = 0.000000; -NODES[3053](BODY_FORCE_Y,0) = -9.810000; -NODES[3053](BODY_FORCE_Z,0) = 0.000000; -NODES[3054](BODY_FORCE_X,0) = 0.000000; -NODES[3054](BODY_FORCE_Y,0) = -9.810000; -NODES[3054](BODY_FORCE_Z,0) = 0.000000; -NODES[3055](BODY_FORCE_X,0) = 0.000000; -NODES[3055](BODY_FORCE_Y,0) = -9.810000; -NODES[3055](BODY_FORCE_Z,0) = 0.000000; -NODES[3056](BODY_FORCE_X,0) = 0.000000; -NODES[3056](BODY_FORCE_Y,0) = -9.810000; -NODES[3056](BODY_FORCE_Z,0) = 0.000000; -NODES[3057](BODY_FORCE_X,0) = 0.000000; -NODES[3057](BODY_FORCE_Y,0) = -9.810000; -NODES[3057](BODY_FORCE_Z,0) = 0.000000; -NODES[3058](BODY_FORCE_X,0) = 0.000000; -NODES[3058](BODY_FORCE_Y,0) = -9.810000; -NODES[3058](BODY_FORCE_Z,0) = 0.000000; -NODES[3059](BODY_FORCE_X,0) = 0.000000; -NODES[3059](BODY_FORCE_Y,0) = -9.810000; -NODES[3059](BODY_FORCE_Z,0) = 0.000000; -NODES[3060](BODY_FORCE_X,0) = 0.000000; -NODES[3060](BODY_FORCE_Y,0) = -9.810000; -NODES[3060](BODY_FORCE_Z,0) = 0.000000; -NODES[3061](BODY_FORCE_X,0) = 0.000000; -NODES[3061](BODY_FORCE_Y,0) = -9.810000; -NODES[3061](BODY_FORCE_Z,0) = 0.000000; -NODES[3062](BODY_FORCE_X,0) = 0.000000; -NODES[3062](BODY_FORCE_Y,0) = -9.810000; -NODES[3062](BODY_FORCE_Z,0) = 0.000000; -NODES[3063](BODY_FORCE_X,0) = 0.000000; -NODES[3063](BODY_FORCE_Y,0) = -9.810000; -NODES[3063](BODY_FORCE_Z,0) = 0.000000; -NODES[3064](BODY_FORCE_X,0) = 0.000000; -NODES[3064](BODY_FORCE_Y,0) = -9.810000; -NODES[3064](BODY_FORCE_Z,0) = 0.000000; -NODES[3065](BODY_FORCE_X,0) = 0.000000; -NODES[3065](BODY_FORCE_Y,0) = -9.810000; -NODES[3065](BODY_FORCE_Z,0) = 0.000000; -NODES[3066](BODY_FORCE_X,0) = 0.000000; -NODES[3066](BODY_FORCE_Y,0) = -9.810000; -NODES[3066](BODY_FORCE_Z,0) = 0.000000; -NODES[3067](BODY_FORCE_X,0) = 0.000000; -NODES[3067](BODY_FORCE_Y,0) = -9.810000; -NODES[3067](BODY_FORCE_Z,0) = 0.000000; -NODES[3068](BODY_FORCE_X,0) = 0.000000; -NODES[3068](BODY_FORCE_Y,0) = -9.810000; -NODES[3068](BODY_FORCE_Z,0) = 0.000000; -NODES[3069](BODY_FORCE_X,0) = 0.000000; -NODES[3069](BODY_FORCE_Y,0) = -9.810000; -NODES[3069](BODY_FORCE_Z,0) = 0.000000; -NODES[3070](BODY_FORCE_X,0) = 0.000000; -NODES[3070](BODY_FORCE_Y,0) = -9.810000; -NODES[3070](BODY_FORCE_Z,0) = 0.000000; -NODES[3071](BODY_FORCE_X,0) = 0.000000; -NODES[3071](BODY_FORCE_Y,0) = -9.810000; -NODES[3071](BODY_FORCE_Z,0) = 0.000000; -NODES[3072](BODY_FORCE_X,0) = 0.000000; -NODES[3072](BODY_FORCE_Y,0) = -9.810000; -NODES[3072](BODY_FORCE_Z,0) = 0.000000; -NODES[3073](BODY_FORCE_X,0) = 0.000000; -NODES[3073](BODY_FORCE_Y,0) = -9.810000; -NODES[3073](BODY_FORCE_Z,0) = 0.000000; -NODES[3074](BODY_FORCE_X,0) = 0.000000; -NODES[3074](BODY_FORCE_Y,0) = -9.810000; -NODES[3074](BODY_FORCE_Z,0) = 0.000000; -NODES[3076](BODY_FORCE_X,0) = 0.000000; -NODES[3076](BODY_FORCE_Y,0) = -9.810000; -NODES[3076](BODY_FORCE_Z,0) = 0.000000; -NODES[3077](BODY_FORCE_X,0) = 0.000000; -NODES[3077](BODY_FORCE_Y,0) = -9.810000; -NODES[3077](BODY_FORCE_Z,0) = 0.000000; -NODES[3078](BODY_FORCE_X,0) = 0.000000; -NODES[3078](BODY_FORCE_Y,0) = -9.810000; -NODES[3078](BODY_FORCE_Z,0) = 0.000000; -NODES[3079](BODY_FORCE_X,0) = 0.000000; -NODES[3079](BODY_FORCE_Y,0) = -9.810000; -NODES[3079](BODY_FORCE_Z,0) = 0.000000; -NODES[3080](BODY_FORCE_X,0) = 0.000000; -NODES[3080](BODY_FORCE_Y,0) = -9.810000; -NODES[3080](BODY_FORCE_Z,0) = 0.000000; -NODES[3081](BODY_FORCE_X,0) = 0.000000; -NODES[3081](BODY_FORCE_Y,0) = -9.810000; -NODES[3081](BODY_FORCE_Z,0) = 0.000000; -NODES[3082](BODY_FORCE_X,0) = 0.000000; -NODES[3082](BODY_FORCE_Y,0) = -9.810000; -NODES[3082](BODY_FORCE_Z,0) = 0.000000; -NODES[3083](BODY_FORCE_X,0) = 0.000000; -NODES[3083](BODY_FORCE_Y,0) = -9.810000; -NODES[3083](BODY_FORCE_Z,0) = 0.000000; -NODES[3084](BODY_FORCE_X,0) = 0.000000; -NODES[3084](BODY_FORCE_Y,0) = -9.810000; -NODES[3084](BODY_FORCE_Z,0) = 0.000000; -NODES[3085](BODY_FORCE_X,0) = 0.000000; -NODES[3085](BODY_FORCE_Y,0) = -9.810000; -NODES[3085](BODY_FORCE_Z,0) = 0.000000; -NODES[3086](BODY_FORCE_X,0) = 0.000000; -NODES[3086](BODY_FORCE_Y,0) = -9.810000; -NODES[3086](BODY_FORCE_Z,0) = 0.000000; -NODES[3087](BODY_FORCE_X,0) = 0.000000; -NODES[3087](BODY_FORCE_Y,0) = -9.810000; -NODES[3087](BODY_FORCE_Z,0) = 0.000000; -NODES[3088](BODY_FORCE_X,0) = 0.000000; -NODES[3088](BODY_FORCE_Y,0) = -9.810000; -NODES[3088](BODY_FORCE_Z,0) = 0.000000; -NODES[3089](BODY_FORCE_X,0) = 0.000000; -NODES[3089](BODY_FORCE_Y,0) = -9.810000; -NODES[3089](BODY_FORCE_Z,0) = 0.000000; -NODES[3090](BODY_FORCE_X,0) = 0.000000; -NODES[3090](BODY_FORCE_Y,0) = -9.810000; -NODES[3090](BODY_FORCE_Z,0) = 0.000000; -NODES[3091](BODY_FORCE_X,0) = 0.000000; -NODES[3091](BODY_FORCE_Y,0) = -9.810000; -NODES[3091](BODY_FORCE_Z,0) = 0.000000; -NODES[3092](BODY_FORCE_X,0) = 0.000000; -NODES[3092](BODY_FORCE_Y,0) = -9.810000; -NODES[3092](BODY_FORCE_Z,0) = 0.000000; -NODES[3093](BODY_FORCE_X,0) = 0.000000; -NODES[3093](BODY_FORCE_Y,0) = -9.810000; -NODES[3093](BODY_FORCE_Z,0) = 0.000000; -NODES[3094](BODY_FORCE_X,0) = 0.000000; -NODES[3094](BODY_FORCE_Y,0) = -9.810000; -NODES[3094](BODY_FORCE_Z,0) = 0.000000; -NODES[3095](BODY_FORCE_X,0) = 0.000000; -NODES[3095](BODY_FORCE_Y,0) = -9.810000; -NODES[3095](BODY_FORCE_Z,0) = 0.000000; -NODES[3096](BODY_FORCE_X,0) = 0.000000; -NODES[3096](BODY_FORCE_Y,0) = -9.810000; -NODES[3096](BODY_FORCE_Z,0) = 0.000000; -NODES[3097](BODY_FORCE_X,0) = 0.000000; -NODES[3097](BODY_FORCE_Y,0) = -9.810000; -NODES[3097](BODY_FORCE_Z,0) = 0.000000; -NODES[3098](BODY_FORCE_X,0) = 0.000000; -NODES[3098](BODY_FORCE_Y,0) = -9.810000; -NODES[3098](BODY_FORCE_Z,0) = 0.000000; -NODES[3099](BODY_FORCE_X,0) = 0.000000; -NODES[3099](BODY_FORCE_Y,0) = -9.810000; -NODES[3099](BODY_FORCE_Z,0) = 0.000000; -NODES[3100](BODY_FORCE_X,0) = 0.000000; -NODES[3100](BODY_FORCE_Y,0) = -9.810000; -NODES[3100](BODY_FORCE_Z,0) = 0.000000; -NODES[3101](BODY_FORCE_X,0) = 0.000000; -NODES[3101](BODY_FORCE_Y,0) = -9.810000; -NODES[3101](BODY_FORCE_Z,0) = 0.000000; -NODES[3103](BODY_FORCE_X,0) = 0.000000; -NODES[3103](BODY_FORCE_Y,0) = -9.810000; -NODES[3103](BODY_FORCE_Z,0) = 0.000000; -NODES[3104](BODY_FORCE_X,0) = 0.000000; -NODES[3104](BODY_FORCE_Y,0) = -9.810000; -NODES[3104](BODY_FORCE_Z,0) = 0.000000; -NODES[3105](BODY_FORCE_X,0) = 0.000000; -NODES[3105](BODY_FORCE_Y,0) = -9.810000; -NODES[3105](BODY_FORCE_Z,0) = 0.000000; -NODES[3106](BODY_FORCE_X,0) = 0.000000; -NODES[3106](BODY_FORCE_Y,0) = -9.810000; -NODES[3106](BODY_FORCE_Z,0) = 0.000000; -NODES[3107](BODY_FORCE_X,0) = 0.000000; -NODES[3107](BODY_FORCE_Y,0) = -9.810000; -NODES[3107](BODY_FORCE_Z,0) = 0.000000; -NODES[3108](BODY_FORCE_X,0) = 0.000000; -NODES[3108](BODY_FORCE_Y,0) = -9.810000; -NODES[3108](BODY_FORCE_Z,0) = 0.000000; -NODES[3109](BODY_FORCE_X,0) = 0.000000; -NODES[3109](BODY_FORCE_Y,0) = -9.810000; -NODES[3109](BODY_FORCE_Z,0) = 0.000000; -NODES[3110](BODY_FORCE_X,0) = 0.000000; -NODES[3110](BODY_FORCE_Y,0) = -9.810000; -NODES[3110](BODY_FORCE_Z,0) = 0.000000; -NODES[3111](BODY_FORCE_X,0) = 0.000000; -NODES[3111](BODY_FORCE_Y,0) = -9.810000; -NODES[3111](BODY_FORCE_Z,0) = 0.000000; -NODES[3112](BODY_FORCE_X,0) = 0.000000; -NODES[3112](BODY_FORCE_Y,0) = -9.810000; -NODES[3112](BODY_FORCE_Z,0) = 0.000000; -NODES[3113](BODY_FORCE_X,0) = 0.000000; -NODES[3113](BODY_FORCE_Y,0) = -9.810000; -NODES[3113](BODY_FORCE_Z,0) = 0.000000; -NODES[3114](BODY_FORCE_X,0) = 0.000000; -NODES[3114](BODY_FORCE_Y,0) = -9.810000; -NODES[3114](BODY_FORCE_Z,0) = 0.000000; -NODES[3115](BODY_FORCE_X,0) = 0.000000; -NODES[3115](BODY_FORCE_Y,0) = -9.810000; -NODES[3115](BODY_FORCE_Z,0) = 0.000000; -NODES[3116](BODY_FORCE_X,0) = 0.000000; -NODES[3116](BODY_FORCE_Y,0) = -9.810000; -NODES[3116](BODY_FORCE_Z,0) = 0.000000; -NODES[3117](BODY_FORCE_X,0) = 0.000000; -NODES[3117](BODY_FORCE_Y,0) = -9.810000; -NODES[3117](BODY_FORCE_Z,0) = 0.000000; -NODES[3118](BODY_FORCE_X,0) = 0.000000; -NODES[3118](BODY_FORCE_Y,0) = -9.810000; -NODES[3118](BODY_FORCE_Z,0) = 0.000000; -NODES[3119](BODY_FORCE_X,0) = 0.000000; -NODES[3119](BODY_FORCE_Y,0) = -9.810000; -NODES[3119](BODY_FORCE_Z,0) = 0.000000; -NODES[3120](BODY_FORCE_X,0) = 0.000000; -NODES[3120](BODY_FORCE_Y,0) = -9.810000; -NODES[3120](BODY_FORCE_Z,0) = 0.000000; -NODES[3121](BODY_FORCE_X,0) = 0.000000; -NODES[3121](BODY_FORCE_Y,0) = -9.810000; -NODES[3121](BODY_FORCE_Z,0) = 0.000000; -NODES[3122](BODY_FORCE_X,0) = 0.000000; -NODES[3122](BODY_FORCE_Y,0) = -9.810000; -NODES[3122](BODY_FORCE_Z,0) = 0.000000; -NODES[3123](BODY_FORCE_X,0) = 0.000000; -NODES[3123](BODY_FORCE_Y,0) = -9.810000; -NODES[3123](BODY_FORCE_Z,0) = 0.000000; -NODES[3124](BODY_FORCE_X,0) = 0.000000; -NODES[3124](BODY_FORCE_Y,0) = -9.810000; -NODES[3124](BODY_FORCE_Z,0) = 0.000000; -NODES[3125](BODY_FORCE_X,0) = 0.000000; -NODES[3125](BODY_FORCE_Y,0) = -9.810000; -NODES[3125](BODY_FORCE_Z,0) = 0.000000; -NODES[3126](BODY_FORCE_X,0) = 0.000000; -NODES[3126](BODY_FORCE_Y,0) = -9.810000; -NODES[3126](BODY_FORCE_Z,0) = 0.000000; -NODES[3127](BODY_FORCE_X,0) = 0.000000; -NODES[3127](BODY_FORCE_Y,0) = -9.810000; -NODES[3127](BODY_FORCE_Z,0) = 0.000000; -NODES[3128](BODY_FORCE_X,0) = 0.000000; -NODES[3128](BODY_FORCE_Y,0) = -9.810000; -NODES[3128](BODY_FORCE_Z,0) = 0.000000; -NODES[3129](BODY_FORCE_X,0) = 0.000000; -NODES[3129](BODY_FORCE_Y,0) = -9.810000; -NODES[3129](BODY_FORCE_Z,0) = 0.000000; -NODES[3130](BODY_FORCE_X,0) = 0.000000; -NODES[3130](BODY_FORCE_Y,0) = -9.810000; -NODES[3130](BODY_FORCE_Z,0) = 0.000000; -NODES[3132](BODY_FORCE_X,0) = 0.000000; -NODES[3132](BODY_FORCE_Y,0) = -9.810000; -NODES[3132](BODY_FORCE_Z,0) = 0.000000; -NODES[3133](BODY_FORCE_X,0) = 0.000000; -NODES[3133](BODY_FORCE_Y,0) = -9.810000; -NODES[3133](BODY_FORCE_Z,0) = 0.000000; -NODES[3134](BODY_FORCE_X,0) = 0.000000; -NODES[3134](BODY_FORCE_Y,0) = -9.810000; -NODES[3134](BODY_FORCE_Z,0) = 0.000000; -NODES[3135](BODY_FORCE_X,0) = 0.000000; -NODES[3135](BODY_FORCE_Y,0) = -9.810000; -NODES[3135](BODY_FORCE_Z,0) = 0.000000; -NODES[3136](BODY_FORCE_X,0) = 0.000000; -NODES[3136](BODY_FORCE_Y,0) = -9.810000; -NODES[3136](BODY_FORCE_Z,0) = 0.000000; -NODES[3137](BODY_FORCE_X,0) = 0.000000; -NODES[3137](BODY_FORCE_Y,0) = -9.810000; -NODES[3137](BODY_FORCE_Z,0) = 0.000000; -NODES[3138](BODY_FORCE_X,0) = 0.000000; -NODES[3138](BODY_FORCE_Y,0) = -9.810000; -NODES[3138](BODY_FORCE_Z,0) = 0.000000; -NODES[3139](BODY_FORCE_X,0) = 0.000000; -NODES[3139](BODY_FORCE_Y,0) = -9.810000; -NODES[3139](BODY_FORCE_Z,0) = 0.000000; -NODES[3140](BODY_FORCE_X,0) = 0.000000; -NODES[3140](BODY_FORCE_Y,0) = -9.810000; -NODES[3140](BODY_FORCE_Z,0) = 0.000000; -NODES[3141](BODY_FORCE_X,0) = 0.000000; -NODES[3141](BODY_FORCE_Y,0) = -9.810000; -NODES[3141](BODY_FORCE_Z,0) = 0.000000; -NODES[3142](BODY_FORCE_X,0) = 0.000000; -NODES[3142](BODY_FORCE_Y,0) = -9.810000; -NODES[3142](BODY_FORCE_Z,0) = 0.000000; -NODES[3143](BODY_FORCE_X,0) = 0.000000; -NODES[3143](BODY_FORCE_Y,0) = -9.810000; -NODES[3143](BODY_FORCE_Z,0) = 0.000000; -NODES[3144](BODY_FORCE_X,0) = 0.000000; -NODES[3144](BODY_FORCE_Y,0) = -9.810000; -NODES[3144](BODY_FORCE_Z,0) = 0.000000; -NODES[3145](BODY_FORCE_X,0) = 0.000000; -NODES[3145](BODY_FORCE_Y,0) = -9.810000; -NODES[3145](BODY_FORCE_Z,0) = 0.000000; -NODES[3146](BODY_FORCE_X,0) = 0.000000; -NODES[3146](BODY_FORCE_Y,0) = -9.810000; -NODES[3146](BODY_FORCE_Z,0) = 0.000000; -NODES[3147](BODY_FORCE_X,0) = 0.000000; -NODES[3147](BODY_FORCE_Y,0) = -9.810000; -NODES[3147](BODY_FORCE_Z,0) = 0.000000; -NODES[3148](BODY_FORCE_X,0) = 0.000000; -NODES[3148](BODY_FORCE_Y,0) = -9.810000; -NODES[3148](BODY_FORCE_Z,0) = 0.000000; -NODES[3149](BODY_FORCE_X,0) = 0.000000; -NODES[3149](BODY_FORCE_Y,0) = -9.810000; -NODES[3149](BODY_FORCE_Z,0) = 0.000000; -NODES[3150](BODY_FORCE_X,0) = 0.000000; -NODES[3150](BODY_FORCE_Y,0) = -9.810000; -NODES[3150](BODY_FORCE_Z,0) = 0.000000; -NODES[3151](BODY_FORCE_X,0) = 0.000000; -NODES[3151](BODY_FORCE_Y,0) = -9.810000; -NODES[3151](BODY_FORCE_Z,0) = 0.000000; -NODES[3152](BODY_FORCE_X,0) = 0.000000; -NODES[3152](BODY_FORCE_Y,0) = -9.810000; -NODES[3152](BODY_FORCE_Z,0) = 0.000000; -NODES[3153](BODY_FORCE_X,0) = 0.000000; -NODES[3153](BODY_FORCE_Y,0) = -9.810000; -NODES[3153](BODY_FORCE_Z,0) = 0.000000; -NODES[3154](BODY_FORCE_X,0) = 0.000000; -NODES[3154](BODY_FORCE_Y,0) = -9.810000; -NODES[3154](BODY_FORCE_Z,0) = 0.000000; -NODES[3155](BODY_FORCE_X,0) = 0.000000; -NODES[3155](BODY_FORCE_Y,0) = -9.810000; -NODES[3155](BODY_FORCE_Z,0) = 0.000000; -NODES[3156](BODY_FORCE_X,0) = 0.000000; -NODES[3156](BODY_FORCE_Y,0) = -9.810000; -NODES[3156](BODY_FORCE_Z,0) = 0.000000; -NODES[3157](BODY_FORCE_X,0) = 0.000000; -NODES[3157](BODY_FORCE_Y,0) = -9.810000; -NODES[3157](BODY_FORCE_Z,0) = 0.000000; -NODES[3158](BODY_FORCE_X,0) = 0.000000; -NODES[3158](BODY_FORCE_Y,0) = -9.810000; -NODES[3158](BODY_FORCE_Z,0) = 0.000000; -NODES[3159](BODY_FORCE_X,0) = 0.000000; -NODES[3159](BODY_FORCE_Y,0) = -9.810000; -NODES[3159](BODY_FORCE_Z,0) = 0.000000; -NODES[3160](BODY_FORCE_X,0) = 0.000000; -NODES[3160](BODY_FORCE_Y,0) = -9.810000; -NODES[3160](BODY_FORCE_Z,0) = 0.000000; -NODES[3162](BODY_FORCE_X,0) = 0.000000; -NODES[3162](BODY_FORCE_Y,0) = -9.810000; -NODES[3162](BODY_FORCE_Z,0) = 0.000000; -NODES[3163](BODY_FORCE_X,0) = 0.000000; -NODES[3163](BODY_FORCE_Y,0) = -9.810000; -NODES[3163](BODY_FORCE_Z,0) = 0.000000; -NODES[3164](BODY_FORCE_X,0) = 0.000000; -NODES[3164](BODY_FORCE_Y,0) = -9.810000; -NODES[3164](BODY_FORCE_Z,0) = 0.000000; -NODES[3165](BODY_FORCE_X,0) = 0.000000; -NODES[3165](BODY_FORCE_Y,0) = -9.810000; -NODES[3165](BODY_FORCE_Z,0) = 0.000000; -NODES[3166](BODY_FORCE_X,0) = 0.000000; -NODES[3166](BODY_FORCE_Y,0) = -9.810000; -NODES[3166](BODY_FORCE_Z,0) = 0.000000; -NODES[3167](BODY_FORCE_X,0) = 0.000000; -NODES[3167](BODY_FORCE_Y,0) = -9.810000; -NODES[3167](BODY_FORCE_Z,0) = 0.000000; -NODES[3168](BODY_FORCE_X,0) = 0.000000; -NODES[3168](BODY_FORCE_Y,0) = -9.810000; -NODES[3168](BODY_FORCE_Z,0) = 0.000000; -NODES[3169](BODY_FORCE_X,0) = 0.000000; -NODES[3169](BODY_FORCE_Y,0) = -9.810000; -NODES[3169](BODY_FORCE_Z,0) = 0.000000; -NODES[3170](BODY_FORCE_X,0) = 0.000000; -NODES[3170](BODY_FORCE_Y,0) = -9.810000; -NODES[3170](BODY_FORCE_Z,0) = 0.000000; -NODES[3171](BODY_FORCE_X,0) = 0.000000; -NODES[3171](BODY_FORCE_Y,0) = -9.810000; -NODES[3171](BODY_FORCE_Z,0) = 0.000000; -NODES[3172](BODY_FORCE_X,0) = 0.000000; -NODES[3172](BODY_FORCE_Y,0) = -9.810000; -NODES[3172](BODY_FORCE_Z,0) = 0.000000; -NODES[3173](BODY_FORCE_X,0) = 0.000000; -NODES[3173](BODY_FORCE_Y,0) = -9.810000; -NODES[3173](BODY_FORCE_Z,0) = 0.000000; -NODES[3174](BODY_FORCE_X,0) = 0.000000; -NODES[3174](BODY_FORCE_Y,0) = -9.810000; -NODES[3174](BODY_FORCE_Z,0) = 0.000000; -NODES[3175](BODY_FORCE_X,0) = 0.000000; -NODES[3175](BODY_FORCE_Y,0) = -9.810000; -NODES[3175](BODY_FORCE_Z,0) = 0.000000; -NODES[3176](BODY_FORCE_X,0) = 0.000000; -NODES[3176](BODY_FORCE_Y,0) = -9.810000; -NODES[3176](BODY_FORCE_Z,0) = 0.000000; -NODES[3177](BODY_FORCE_X,0) = 0.000000; -NODES[3177](BODY_FORCE_Y,0) = -9.810000; -NODES[3177](BODY_FORCE_Z,0) = 0.000000; -NODES[3178](BODY_FORCE_X,0) = 0.000000; -NODES[3178](BODY_FORCE_Y,0) = -9.810000; -NODES[3178](BODY_FORCE_Z,0) = 0.000000; -NODES[3179](BODY_FORCE_X,0) = 0.000000; -NODES[3179](BODY_FORCE_Y,0) = -9.810000; -NODES[3179](BODY_FORCE_Z,0) = 0.000000; -NODES[3180](BODY_FORCE_X,0) = 0.000000; -NODES[3180](BODY_FORCE_Y,0) = -9.810000; -NODES[3180](BODY_FORCE_Z,0) = 0.000000; -NODES[3181](BODY_FORCE_X,0) = 0.000000; -NODES[3181](BODY_FORCE_Y,0) = -9.810000; -NODES[3181](BODY_FORCE_Z,0) = 0.000000; -NODES[3182](BODY_FORCE_X,0) = 0.000000; -NODES[3182](BODY_FORCE_Y,0) = -9.810000; -NODES[3182](BODY_FORCE_Z,0) = 0.000000; -NODES[3183](BODY_FORCE_X,0) = 0.000000; -NODES[3183](BODY_FORCE_Y,0) = -9.810000; -NODES[3183](BODY_FORCE_Z,0) = 0.000000; -NODES[3184](BODY_FORCE_X,0) = 0.000000; -NODES[3184](BODY_FORCE_Y,0) = -9.810000; -NODES[3184](BODY_FORCE_Z,0) = 0.000000; -NODES[3185](BODY_FORCE_X,0) = 0.000000; -NODES[3185](BODY_FORCE_Y,0) = -9.810000; -NODES[3185](BODY_FORCE_Z,0) = 0.000000; -NODES[3186](BODY_FORCE_X,0) = 0.000000; -NODES[3186](BODY_FORCE_Y,0) = -9.810000; -NODES[3186](BODY_FORCE_Z,0) = 0.000000; -NODES[3187](BODY_FORCE_X,0) = 0.000000; -NODES[3187](BODY_FORCE_Y,0) = -9.810000; -NODES[3187](BODY_FORCE_Z,0) = 0.000000; -NODES[3189](BODY_FORCE_X,0) = 0.000000; -NODES[3189](BODY_FORCE_Y,0) = -9.810000; -NODES[3189](BODY_FORCE_Z,0) = 0.000000; -NODES[3190](BODY_FORCE_X,0) = 0.000000; -NODES[3190](BODY_FORCE_Y,0) = -9.810000; -NODES[3190](BODY_FORCE_Z,0) = 0.000000; -NODES[3191](BODY_FORCE_X,0) = 0.000000; -NODES[3191](BODY_FORCE_Y,0) = -9.810000; -NODES[3191](BODY_FORCE_Z,0) = 0.000000; -NODES[3192](BODY_FORCE_X,0) = 0.000000; -NODES[3192](BODY_FORCE_Y,0) = -9.810000; -NODES[3192](BODY_FORCE_Z,0) = 0.000000; -NODES[3193](BODY_FORCE_X,0) = 0.000000; -NODES[3193](BODY_FORCE_Y,0) = -9.810000; -NODES[3193](BODY_FORCE_Z,0) = 0.000000; -NODES[3194](BODY_FORCE_X,0) = 0.000000; -NODES[3194](BODY_FORCE_Y,0) = -9.810000; -NODES[3194](BODY_FORCE_Z,0) = 0.000000; -NODES[3195](BODY_FORCE_X,0) = 0.000000; -NODES[3195](BODY_FORCE_Y,0) = -9.810000; -NODES[3195](BODY_FORCE_Z,0) = 0.000000; -NODES[3196](BODY_FORCE_X,0) = 0.000000; -NODES[3196](BODY_FORCE_Y,0) = -9.810000; -NODES[3196](BODY_FORCE_Z,0) = 0.000000; -NODES[3197](BODY_FORCE_X,0) = 0.000000; -NODES[3197](BODY_FORCE_Y,0) = -9.810000; -NODES[3197](BODY_FORCE_Z,0) = 0.000000; -NODES[3198](BODY_FORCE_X,0) = 0.000000; -NODES[3198](BODY_FORCE_Y,0) = -9.810000; -NODES[3198](BODY_FORCE_Z,0) = 0.000000; -NODES[3199](BODY_FORCE_X,0) = 0.000000; -NODES[3199](BODY_FORCE_Y,0) = -9.810000; -NODES[3199](BODY_FORCE_Z,0) = 0.000000; -NODES[3200](BODY_FORCE_X,0) = 0.000000; -NODES[3200](BODY_FORCE_Y,0) = -9.810000; -NODES[3200](BODY_FORCE_Z,0) = 0.000000; -NODES[3201](BODY_FORCE_X,0) = 0.000000; -NODES[3201](BODY_FORCE_Y,0) = -9.810000; -NODES[3201](BODY_FORCE_Z,0) = 0.000000; -NODES[3202](BODY_FORCE_X,0) = 0.000000; -NODES[3202](BODY_FORCE_Y,0) = -9.810000; -NODES[3202](BODY_FORCE_Z,0) = 0.000000; -NODES[3203](BODY_FORCE_X,0) = 0.000000; -NODES[3203](BODY_FORCE_Y,0) = -9.810000; -NODES[3203](BODY_FORCE_Z,0) = 0.000000; -NODES[3204](BODY_FORCE_X,0) = 0.000000; -NODES[3204](BODY_FORCE_Y,0) = -9.810000; -NODES[3204](BODY_FORCE_Z,0) = 0.000000; -NODES[3205](BODY_FORCE_X,0) = 0.000000; -NODES[3205](BODY_FORCE_Y,0) = -9.810000; -NODES[3205](BODY_FORCE_Z,0) = 0.000000; -NODES[3206](BODY_FORCE_X,0) = 0.000000; -NODES[3206](BODY_FORCE_Y,0) = -9.810000; -NODES[3206](BODY_FORCE_Z,0) = 0.000000; -NODES[3207](BODY_FORCE_X,0) = 0.000000; -NODES[3207](BODY_FORCE_Y,0) = -9.810000; -NODES[3207](BODY_FORCE_Z,0) = 0.000000; -NODES[3208](BODY_FORCE_X,0) = 0.000000; -NODES[3208](BODY_FORCE_Y,0) = -9.810000; -NODES[3208](BODY_FORCE_Z,0) = 0.000000; -NODES[3209](BODY_FORCE_X,0) = 0.000000; -NODES[3209](BODY_FORCE_Y,0) = -9.810000; -NODES[3209](BODY_FORCE_Z,0) = 0.000000; -NODES[3210](BODY_FORCE_X,0) = 0.000000; -NODES[3210](BODY_FORCE_Y,0) = -9.810000; -NODES[3210](BODY_FORCE_Z,0) = 0.000000; -NODES[3211](BODY_FORCE_X,0) = 0.000000; -NODES[3211](BODY_FORCE_Y,0) = -9.810000; -NODES[3211](BODY_FORCE_Z,0) = 0.000000; -NODES[3212](BODY_FORCE_X,0) = 0.000000; -NODES[3212](BODY_FORCE_Y,0) = -9.810000; -NODES[3212](BODY_FORCE_Z,0) = 0.000000; -NODES[3213](BODY_FORCE_X,0) = 0.000000; -NODES[3213](BODY_FORCE_Y,0) = -9.810000; -NODES[3213](BODY_FORCE_Z,0) = 0.000000; -NODES[3214](BODY_FORCE_X,0) = 0.000000; -NODES[3214](BODY_FORCE_Y,0) = -9.810000; -NODES[3214](BODY_FORCE_Z,0) = 0.000000; -NODES[3216](BODY_FORCE_X,0) = 0.000000; -NODES[3216](BODY_FORCE_Y,0) = -9.810000; -NODES[3216](BODY_FORCE_Z,0) = 0.000000; -NODES[3217](BODY_FORCE_X,0) = 0.000000; -NODES[3217](BODY_FORCE_Y,0) = -9.810000; -NODES[3217](BODY_FORCE_Z,0) = 0.000000; -NODES[3218](BODY_FORCE_X,0) = 0.000000; -NODES[3218](BODY_FORCE_Y,0) = -9.810000; -NODES[3218](BODY_FORCE_Z,0) = 0.000000; -NODES[3219](BODY_FORCE_X,0) = 0.000000; -NODES[3219](BODY_FORCE_Y,0) = -9.810000; -NODES[3219](BODY_FORCE_Z,0) = 0.000000; -NODES[3220](BODY_FORCE_X,0) = 0.000000; -NODES[3220](BODY_FORCE_Y,0) = -9.810000; -NODES[3220](BODY_FORCE_Z,0) = 0.000000; -NODES[3221](BODY_FORCE_X,0) = 0.000000; -NODES[3221](BODY_FORCE_Y,0) = -9.810000; -NODES[3221](BODY_FORCE_Z,0) = 0.000000; -NODES[3222](BODY_FORCE_X,0) = 0.000000; -NODES[3222](BODY_FORCE_Y,0) = -9.810000; -NODES[3222](BODY_FORCE_Z,0) = 0.000000; -NODES[3223](BODY_FORCE_X,0) = 0.000000; -NODES[3223](BODY_FORCE_Y,0) = -9.810000; -NODES[3223](BODY_FORCE_Z,0) = 0.000000; -NODES[3224](BODY_FORCE_X,0) = 0.000000; -NODES[3224](BODY_FORCE_Y,0) = -9.810000; -NODES[3224](BODY_FORCE_Z,0) = 0.000000; -NODES[3225](BODY_FORCE_X,0) = 0.000000; -NODES[3225](BODY_FORCE_Y,0) = -9.810000; -NODES[3225](BODY_FORCE_Z,0) = 0.000000; -NODES[3226](BODY_FORCE_X,0) = 0.000000; -NODES[3226](BODY_FORCE_Y,0) = -9.810000; -NODES[3226](BODY_FORCE_Z,0) = 0.000000; -NODES[3227](BODY_FORCE_X,0) = 0.000000; -NODES[3227](BODY_FORCE_Y,0) = -9.810000; -NODES[3227](BODY_FORCE_Z,0) = 0.000000; -NODES[3228](BODY_FORCE_X,0) = 0.000000; -NODES[3228](BODY_FORCE_Y,0) = -9.810000; -NODES[3228](BODY_FORCE_Z,0) = 0.000000; -NODES[3229](BODY_FORCE_X,0) = 0.000000; -NODES[3229](BODY_FORCE_Y,0) = -9.810000; -NODES[3229](BODY_FORCE_Z,0) = 0.000000; -NODES[3230](BODY_FORCE_X,0) = 0.000000; -NODES[3230](BODY_FORCE_Y,0) = -9.810000; -NODES[3230](BODY_FORCE_Z,0) = 0.000000; -NODES[3231](BODY_FORCE_X,0) = 0.000000; -NODES[3231](BODY_FORCE_Y,0) = -9.810000; -NODES[3231](BODY_FORCE_Z,0) = 0.000000; -NODES[3232](BODY_FORCE_X,0) = 0.000000; -NODES[3232](BODY_FORCE_Y,0) = -9.810000; -NODES[3232](BODY_FORCE_Z,0) = 0.000000; -NODES[3233](BODY_FORCE_X,0) = 0.000000; -NODES[3233](BODY_FORCE_Y,0) = -9.810000; -NODES[3233](BODY_FORCE_Z,0) = 0.000000; -NODES[3234](BODY_FORCE_X,0) = 0.000000; -NODES[3234](BODY_FORCE_Y,0) = -9.810000; -NODES[3234](BODY_FORCE_Z,0) = 0.000000; -NODES[3235](BODY_FORCE_X,0) = 0.000000; -NODES[3235](BODY_FORCE_Y,0) = -9.810000; -NODES[3235](BODY_FORCE_Z,0) = 0.000000; -NODES[3236](BODY_FORCE_X,0) = 0.000000; -NODES[3236](BODY_FORCE_Y,0) = -9.810000; -NODES[3236](BODY_FORCE_Z,0) = 0.000000; -NODES[3237](BODY_FORCE_X,0) = 0.000000; -NODES[3237](BODY_FORCE_Y,0) = -9.810000; -NODES[3237](BODY_FORCE_Z,0) = 0.000000; -NODES[3238](BODY_FORCE_X,0) = 0.000000; -NODES[3238](BODY_FORCE_Y,0) = -9.810000; -NODES[3238](BODY_FORCE_Z,0) = 0.000000; -NODES[3239](BODY_FORCE_X,0) = 0.000000; -NODES[3239](BODY_FORCE_Y,0) = -9.810000; -NODES[3239](BODY_FORCE_Z,0) = 0.000000; -NODES[3240](BODY_FORCE_X,0) = 0.000000; -NODES[3240](BODY_FORCE_Y,0) = -9.810000; -NODES[3240](BODY_FORCE_Z,0) = 0.000000; -NODES[3241](BODY_FORCE_X,0) = 0.000000; -NODES[3241](BODY_FORCE_Y,0) = -9.810000; -NODES[3241](BODY_FORCE_Z,0) = 0.000000; -NODES[3243](BODY_FORCE_X,0) = 0.000000; -NODES[3243](BODY_FORCE_Y,0) = -9.810000; -NODES[3243](BODY_FORCE_Z,0) = 0.000000; -NODES[3244](BODY_FORCE_X,0) = 0.000000; -NODES[3244](BODY_FORCE_Y,0) = -9.810000; -NODES[3244](BODY_FORCE_Z,0) = 0.000000; -NODES[3245](BODY_FORCE_X,0) = 0.000000; -NODES[3245](BODY_FORCE_Y,0) = -9.810000; -NODES[3245](BODY_FORCE_Z,0) = 0.000000; -NODES[3246](BODY_FORCE_X,0) = 0.000000; -NODES[3246](BODY_FORCE_Y,0) = -9.810000; -NODES[3246](BODY_FORCE_Z,0) = 0.000000; -NODES[3247](BODY_FORCE_X,0) = 0.000000; -NODES[3247](BODY_FORCE_Y,0) = -9.810000; -NODES[3247](BODY_FORCE_Z,0) = 0.000000; -NODES[3248](BODY_FORCE_X,0) = 0.000000; -NODES[3248](BODY_FORCE_Y,0) = -9.810000; -NODES[3248](BODY_FORCE_Z,0) = 0.000000; -NODES[3249](BODY_FORCE_X,0) = 0.000000; -NODES[3249](BODY_FORCE_Y,0) = -9.810000; -NODES[3249](BODY_FORCE_Z,0) = 0.000000; -NODES[3250](BODY_FORCE_X,0) = 0.000000; -NODES[3250](BODY_FORCE_Y,0) = -9.810000; -NODES[3250](BODY_FORCE_Z,0) = 0.000000; -NODES[3251](BODY_FORCE_X,0) = 0.000000; -NODES[3251](BODY_FORCE_Y,0) = -9.810000; -NODES[3251](BODY_FORCE_Z,0) = 0.000000; -NODES[3252](BODY_FORCE_X,0) = 0.000000; -NODES[3252](BODY_FORCE_Y,0) = -9.810000; -NODES[3252](BODY_FORCE_Z,0) = 0.000000; -NODES[3253](BODY_FORCE_X,0) = 0.000000; -NODES[3253](BODY_FORCE_Y,0) = -9.810000; -NODES[3253](BODY_FORCE_Z,0) = 0.000000; -NODES[3254](BODY_FORCE_X,0) = 0.000000; -NODES[3254](BODY_FORCE_Y,0) = -9.810000; -NODES[3254](BODY_FORCE_Z,0) = 0.000000; -NODES[3255](BODY_FORCE_X,0) = 0.000000; -NODES[3255](BODY_FORCE_Y,0) = -9.810000; -NODES[3255](BODY_FORCE_Z,0) = 0.000000; -NODES[3256](BODY_FORCE_X,0) = 0.000000; -NODES[3256](BODY_FORCE_Y,0) = -9.810000; -NODES[3256](BODY_FORCE_Z,0) = 0.000000; -NODES[3257](BODY_FORCE_X,0) = 0.000000; -NODES[3257](BODY_FORCE_Y,0) = -9.810000; -NODES[3257](BODY_FORCE_Z,0) = 0.000000; -NODES[3258](BODY_FORCE_X,0) = 0.000000; -NODES[3258](BODY_FORCE_Y,0) = -9.810000; -NODES[3258](BODY_FORCE_Z,0) = 0.000000; -NODES[3259](BODY_FORCE_X,0) = 0.000000; -NODES[3259](BODY_FORCE_Y,0) = -9.810000; -NODES[3259](BODY_FORCE_Z,0) = 0.000000; -NODES[3260](BODY_FORCE_X,0) = 0.000000; -NODES[3260](BODY_FORCE_Y,0) = -9.810000; -NODES[3260](BODY_FORCE_Z,0) = 0.000000; -NODES[3261](BODY_FORCE_X,0) = 0.000000; -NODES[3261](BODY_FORCE_Y,0) = -9.810000; -NODES[3261](BODY_FORCE_Z,0) = 0.000000; -NODES[3262](BODY_FORCE_X,0) = 0.000000; -NODES[3262](BODY_FORCE_Y,0) = -9.810000; -NODES[3262](BODY_FORCE_Z,0) = 0.000000; -NODES[3263](BODY_FORCE_X,0) = 0.000000; -NODES[3263](BODY_FORCE_Y,0) = -9.810000; -NODES[3263](BODY_FORCE_Z,0) = 0.000000; -NODES[3264](BODY_FORCE_X,0) = 0.000000; -NODES[3264](BODY_FORCE_Y,0) = -9.810000; -NODES[3264](BODY_FORCE_Z,0) = 0.000000; -NODES[3265](BODY_FORCE_X,0) = 0.000000; -NODES[3265](BODY_FORCE_Y,0) = -9.810000; -NODES[3265](BODY_FORCE_Z,0) = 0.000000; -NODES[3266](BODY_FORCE_X,0) = 0.000000; -NODES[3266](BODY_FORCE_Y,0) = -9.810000; -NODES[3266](BODY_FORCE_Z,0) = 0.000000; -NODES[3268](BODY_FORCE_X,0) = 0.000000; -NODES[3268](BODY_FORCE_Y,0) = -9.810000; -NODES[3268](BODY_FORCE_Z,0) = 0.000000; -NODES[3269](BODY_FORCE_X,0) = 0.000000; -NODES[3269](BODY_FORCE_Y,0) = -9.810000; -NODES[3269](BODY_FORCE_Z,0) = 0.000000; -NODES[3270](BODY_FORCE_X,0) = 0.000000; -NODES[3270](BODY_FORCE_Y,0) = -9.810000; -NODES[3270](BODY_FORCE_Z,0) = 0.000000; -NODES[3271](BODY_FORCE_X,0) = 0.000000; -NODES[3271](BODY_FORCE_Y,0) = -9.810000; -NODES[3271](BODY_FORCE_Z,0) = 0.000000; -NODES[3272](BODY_FORCE_X,0) = 0.000000; -NODES[3272](BODY_FORCE_Y,0) = -9.810000; -NODES[3272](BODY_FORCE_Z,0) = 0.000000; -NODES[3273](BODY_FORCE_X,0) = 0.000000; -NODES[3273](BODY_FORCE_Y,0) = -9.810000; -NODES[3273](BODY_FORCE_Z,0) = 0.000000; -NODES[3274](BODY_FORCE_X,0) = 0.000000; -NODES[3274](BODY_FORCE_Y,0) = -9.810000; -NODES[3274](BODY_FORCE_Z,0) = 0.000000; -NODES[3275](BODY_FORCE_X,0) = 0.000000; -NODES[3275](BODY_FORCE_Y,0) = -9.810000; -NODES[3275](BODY_FORCE_Z,0) = 0.000000; -NODES[3276](BODY_FORCE_X,0) = 0.000000; -NODES[3276](BODY_FORCE_Y,0) = -9.810000; -NODES[3276](BODY_FORCE_Z,0) = 0.000000; -NODES[3277](BODY_FORCE_X,0) = 0.000000; -NODES[3277](BODY_FORCE_Y,0) = -9.810000; -NODES[3277](BODY_FORCE_Z,0) = 0.000000; -NODES[3278](BODY_FORCE_X,0) = 0.000000; -NODES[3278](BODY_FORCE_Y,0) = -9.810000; -NODES[3278](BODY_FORCE_Z,0) = 0.000000; -NODES[3279](BODY_FORCE_X,0) = 0.000000; -NODES[3279](BODY_FORCE_Y,0) = -9.810000; -NODES[3279](BODY_FORCE_Z,0) = 0.000000; -NODES[3280](BODY_FORCE_X,0) = 0.000000; -NODES[3280](BODY_FORCE_Y,0) = -9.810000; -NODES[3280](BODY_FORCE_Z,0) = 0.000000; -NODES[3281](BODY_FORCE_X,0) = 0.000000; -NODES[3281](BODY_FORCE_Y,0) = -9.810000; -NODES[3281](BODY_FORCE_Z,0) = 0.000000; -NODES[3282](BODY_FORCE_X,0) = 0.000000; -NODES[3282](BODY_FORCE_Y,0) = -9.810000; -NODES[3282](BODY_FORCE_Z,0) = 0.000000; -NODES[3283](BODY_FORCE_X,0) = 0.000000; -NODES[3283](BODY_FORCE_Y,0) = -9.810000; -NODES[3283](BODY_FORCE_Z,0) = 0.000000; -NODES[3284](BODY_FORCE_X,0) = 0.000000; -NODES[3284](BODY_FORCE_Y,0) = -9.810000; -NODES[3284](BODY_FORCE_Z,0) = 0.000000; -NODES[3285](BODY_FORCE_X,0) = 0.000000; -NODES[3285](BODY_FORCE_Y,0) = -9.810000; -NODES[3285](BODY_FORCE_Z,0) = 0.000000; -NODES[3286](BODY_FORCE_X,0) = 0.000000; -NODES[3286](BODY_FORCE_Y,0) = -9.810000; -NODES[3286](BODY_FORCE_Z,0) = 0.000000; -NODES[3287](BODY_FORCE_X,0) = 0.000000; -NODES[3287](BODY_FORCE_Y,0) = -9.810000; -NODES[3287](BODY_FORCE_Z,0) = 0.000000; -NODES[3288](BODY_FORCE_X,0) = 0.000000; -NODES[3288](BODY_FORCE_Y,0) = -9.810000; -NODES[3288](BODY_FORCE_Z,0) = 0.000000; -NODES[3289](BODY_FORCE_X,0) = 0.000000; -NODES[3289](BODY_FORCE_Y,0) = -9.810000; -NODES[3289](BODY_FORCE_Z,0) = 0.000000; -NODES[3290](BODY_FORCE_X,0) = 0.000000; -NODES[3290](BODY_FORCE_Y,0) = -9.810000; -NODES[3290](BODY_FORCE_Z,0) = 0.000000; -NODES[3291](BODY_FORCE_X,0) = 0.000000; -NODES[3291](BODY_FORCE_Y,0) = -9.810000; -NODES[3291](BODY_FORCE_Z,0) = 0.000000; -NODES[3293](BODY_FORCE_X,0) = 0.000000; -NODES[3293](BODY_FORCE_Y,0) = -9.810000; -NODES[3293](BODY_FORCE_Z,0) = 0.000000; -NODES[3294](BODY_FORCE_X,0) = 0.000000; -NODES[3294](BODY_FORCE_Y,0) = -9.810000; -NODES[3294](BODY_FORCE_Z,0) = 0.000000; -NODES[3295](BODY_FORCE_X,0) = 0.000000; -NODES[3295](BODY_FORCE_Y,0) = -9.810000; -NODES[3295](BODY_FORCE_Z,0) = 0.000000; -NODES[3296](BODY_FORCE_X,0) = 0.000000; -NODES[3296](BODY_FORCE_Y,0) = -9.810000; -NODES[3296](BODY_FORCE_Z,0) = 0.000000; -NODES[3297](BODY_FORCE_X,0) = 0.000000; -NODES[3297](BODY_FORCE_Y,0) = -9.810000; -NODES[3297](BODY_FORCE_Z,0) = 0.000000; -NODES[3298](BODY_FORCE_X,0) = 0.000000; -NODES[3298](BODY_FORCE_Y,0) = -9.810000; -NODES[3298](BODY_FORCE_Z,0) = 0.000000; -NODES[3299](BODY_FORCE_X,0) = 0.000000; -NODES[3299](BODY_FORCE_Y,0) = -9.810000; -NODES[3299](BODY_FORCE_Z,0) = 0.000000; -NODES[3300](BODY_FORCE_X,0) = 0.000000; -NODES[3300](BODY_FORCE_Y,0) = -9.810000; -NODES[3300](BODY_FORCE_Z,0) = 0.000000; -NODES[3301](BODY_FORCE_X,0) = 0.000000; -NODES[3301](BODY_FORCE_Y,0) = -9.810000; -NODES[3301](BODY_FORCE_Z,0) = 0.000000; -NODES[3302](BODY_FORCE_X,0) = 0.000000; -NODES[3302](BODY_FORCE_Y,0) = -9.810000; -NODES[3302](BODY_FORCE_Z,0) = 0.000000; -NODES[3303](BODY_FORCE_X,0) = 0.000000; -NODES[3303](BODY_FORCE_Y,0) = -9.810000; -NODES[3303](BODY_FORCE_Z,0) = 0.000000; -NODES[3304](BODY_FORCE_X,0) = 0.000000; -NODES[3304](BODY_FORCE_Y,0) = -9.810000; -NODES[3304](BODY_FORCE_Z,0) = 0.000000; -NODES[3305](BODY_FORCE_X,0) = 0.000000; -NODES[3305](BODY_FORCE_Y,0) = -9.810000; -NODES[3305](BODY_FORCE_Z,0) = 0.000000; -NODES[3306](BODY_FORCE_X,0) = 0.000000; -NODES[3306](BODY_FORCE_Y,0) = -9.810000; -NODES[3306](BODY_FORCE_Z,0) = 0.000000; -NODES[3307](BODY_FORCE_X,0) = 0.000000; -NODES[3307](BODY_FORCE_Y,0) = -9.810000; -NODES[3307](BODY_FORCE_Z,0) = 0.000000; -NODES[3308](BODY_FORCE_X,0) = 0.000000; -NODES[3308](BODY_FORCE_Y,0) = -9.810000; -NODES[3308](BODY_FORCE_Z,0) = 0.000000; -NODES[3309](BODY_FORCE_X,0) = 0.000000; -NODES[3309](BODY_FORCE_Y,0) = -9.810000; -NODES[3309](BODY_FORCE_Z,0) = 0.000000; -NODES[3310](BODY_FORCE_X,0) = 0.000000; -NODES[3310](BODY_FORCE_Y,0) = -9.810000; -NODES[3310](BODY_FORCE_Z,0) = 0.000000; -NODES[3311](BODY_FORCE_X,0) = 0.000000; -NODES[3311](BODY_FORCE_Y,0) = -9.810000; -NODES[3311](BODY_FORCE_Z,0) = 0.000000; -NODES[3312](BODY_FORCE_X,0) = 0.000000; -NODES[3312](BODY_FORCE_Y,0) = -9.810000; -NODES[3312](BODY_FORCE_Z,0) = 0.000000; -NODES[3313](BODY_FORCE_X,0) = 0.000000; -NODES[3313](BODY_FORCE_Y,0) = -9.810000; -NODES[3313](BODY_FORCE_Z,0) = 0.000000; -NODES[3314](BODY_FORCE_X,0) = 0.000000; -NODES[3314](BODY_FORCE_Y,0) = -9.810000; -NODES[3314](BODY_FORCE_Z,0) = 0.000000; -NODES[3315](BODY_FORCE_X,0) = 0.000000; -NODES[3315](BODY_FORCE_Y,0) = -9.810000; -NODES[3315](BODY_FORCE_Z,0) = 0.000000; -NODES[3316](BODY_FORCE_X,0) = 0.000000; -NODES[3316](BODY_FORCE_Y,0) = -9.810000; -NODES[3316](BODY_FORCE_Z,0) = 0.000000; -NODES[3317](BODY_FORCE_X,0) = 0.000000; -NODES[3317](BODY_FORCE_Y,0) = -9.810000; -NODES[3317](BODY_FORCE_Z,0) = 0.000000; -NODES[3318](BODY_FORCE_X,0) = 0.000000; -NODES[3318](BODY_FORCE_Y,0) = -9.810000; -NODES[3318](BODY_FORCE_Z,0) = 0.000000; -NODES[3319](BODY_FORCE_X,0) = 0.000000; -NODES[3319](BODY_FORCE_Y,0) = -9.810000; -NODES[3319](BODY_FORCE_Z,0) = 0.000000; -NODES[3320](BODY_FORCE_X,0) = 0.000000; -NODES[3320](BODY_FORCE_Y,0) = -9.810000; -NODES[3320](BODY_FORCE_Z,0) = 0.000000; -NODES[3321](BODY_FORCE_X,0) = 0.000000; -NODES[3321](BODY_FORCE_Y,0) = -9.810000; -NODES[3321](BODY_FORCE_Z,0) = 0.000000; -NODES[3322](BODY_FORCE_X,0) = 0.000000; -NODES[3322](BODY_FORCE_Y,0) = -9.810000; -NODES[3322](BODY_FORCE_Z,0) = 0.000000; -NODES[3324](BODY_FORCE_X,0) = 0.000000; -NODES[3324](BODY_FORCE_Y,0) = -9.810000; -NODES[3324](BODY_FORCE_Z,0) = 0.000000; -NODES[3325](BODY_FORCE_X,0) = 0.000000; -NODES[3325](BODY_FORCE_Y,0) = -9.810000; -NODES[3325](BODY_FORCE_Z,0) = 0.000000; -NODES[3326](BODY_FORCE_X,0) = 0.000000; -NODES[3326](BODY_FORCE_Y,0) = -9.810000; -NODES[3326](BODY_FORCE_Z,0) = 0.000000; -NODES[3327](BODY_FORCE_X,0) = 0.000000; -NODES[3327](BODY_FORCE_Y,0) = -9.810000; -NODES[3327](BODY_FORCE_Z,0) = 0.000000; -NODES[3328](BODY_FORCE_X,0) = 0.000000; -NODES[3328](BODY_FORCE_Y,0) = -9.810000; -NODES[3328](BODY_FORCE_Z,0) = 0.000000; -NODES[3329](BODY_FORCE_X,0) = 0.000000; -NODES[3329](BODY_FORCE_Y,0) = -9.810000; -NODES[3329](BODY_FORCE_Z,0) = 0.000000; -NODES[3330](BODY_FORCE_X,0) = 0.000000; -NODES[3330](BODY_FORCE_Y,0) = -9.810000; -NODES[3330](BODY_FORCE_Z,0) = 0.000000; -NODES[3331](BODY_FORCE_X,0) = 0.000000; -NODES[3331](BODY_FORCE_Y,0) = -9.810000; -NODES[3331](BODY_FORCE_Z,0) = 0.000000; -NODES[3332](BODY_FORCE_X,0) = 0.000000; -NODES[3332](BODY_FORCE_Y,0) = -9.810000; -NODES[3332](BODY_FORCE_Z,0) = 0.000000; -NODES[3333](BODY_FORCE_X,0) = 0.000000; -NODES[3333](BODY_FORCE_Y,0) = -9.810000; -NODES[3333](BODY_FORCE_Z,0) = 0.000000; -NODES[3334](BODY_FORCE_X,0) = 0.000000; -NODES[3334](BODY_FORCE_Y,0) = -9.810000; -NODES[3334](BODY_FORCE_Z,0) = 0.000000; -NODES[3335](BODY_FORCE_X,0) = 0.000000; -NODES[3335](BODY_FORCE_Y,0) = -9.810000; -NODES[3335](BODY_FORCE_Z,0) = 0.000000; -NODES[3336](BODY_FORCE_X,0) = 0.000000; -NODES[3336](BODY_FORCE_Y,0) = -9.810000; -NODES[3336](BODY_FORCE_Z,0) = 0.000000; -NODES[3337](BODY_FORCE_X,0) = 0.000000; -NODES[3337](BODY_FORCE_Y,0) = -9.810000; -NODES[3337](BODY_FORCE_Z,0) = 0.000000; -NODES[3338](BODY_FORCE_X,0) = 0.000000; -NODES[3338](BODY_FORCE_Y,0) = -9.810000; -NODES[3338](BODY_FORCE_Z,0) = 0.000000; -NODES[3339](BODY_FORCE_X,0) = 0.000000; -NODES[3339](BODY_FORCE_Y,0) = -9.810000; -NODES[3339](BODY_FORCE_Z,0) = 0.000000; -NODES[3340](BODY_FORCE_X,0) = 0.000000; -NODES[3340](BODY_FORCE_Y,0) = -9.810000; -NODES[3340](BODY_FORCE_Z,0) = 0.000000; -NODES[3341](BODY_FORCE_X,0) = 0.000000; -NODES[3341](BODY_FORCE_Y,0) = -9.810000; -NODES[3341](BODY_FORCE_Z,0) = 0.000000; -NODES[3342](BODY_FORCE_X,0) = 0.000000; -NODES[3342](BODY_FORCE_Y,0) = -9.810000; -NODES[3342](BODY_FORCE_Z,0) = 0.000000; -NODES[3343](BODY_FORCE_X,0) = 0.000000; -NODES[3343](BODY_FORCE_Y,0) = -9.810000; -NODES[3343](BODY_FORCE_Z,0) = 0.000000; -NODES[3344](BODY_FORCE_X,0) = 0.000000; -NODES[3344](BODY_FORCE_Y,0) = -9.810000; -NODES[3344](BODY_FORCE_Z,0) = 0.000000; -NODES[3345](BODY_FORCE_X,0) = 0.000000; -NODES[3345](BODY_FORCE_Y,0) = -9.810000; -NODES[3345](BODY_FORCE_Z,0) = 0.000000; -NODES[3346](BODY_FORCE_X,0) = 0.000000; -NODES[3346](BODY_FORCE_Y,0) = -9.810000; -NODES[3346](BODY_FORCE_Z,0) = 0.000000; -NODES[3347](BODY_FORCE_X,0) = 0.000000; -NODES[3347](BODY_FORCE_Y,0) = -9.810000; -NODES[3347](BODY_FORCE_Z,0) = 0.000000; -NODES[3348](BODY_FORCE_X,0) = 0.000000; -NODES[3348](BODY_FORCE_Y,0) = -9.810000; -NODES[3348](BODY_FORCE_Z,0) = 0.000000; -NODES[3350](BODY_FORCE_X,0) = 0.000000; -NODES[3350](BODY_FORCE_Y,0) = -9.810000; -NODES[3350](BODY_FORCE_Z,0) = 0.000000; -NODES[3351](BODY_FORCE_X,0) = 0.000000; -NODES[3351](BODY_FORCE_Y,0) = -9.810000; -NODES[3351](BODY_FORCE_Z,0) = 0.000000; -NODES[3352](BODY_FORCE_X,0) = 0.000000; -NODES[3352](BODY_FORCE_Y,0) = -9.810000; -NODES[3352](BODY_FORCE_Z,0) = 0.000000; -NODES[3353](BODY_FORCE_X,0) = 0.000000; -NODES[3353](BODY_FORCE_Y,0) = -9.810000; -NODES[3353](BODY_FORCE_Z,0) = 0.000000; -NODES[3354](BODY_FORCE_X,0) = 0.000000; -NODES[3354](BODY_FORCE_Y,0) = -9.810000; -NODES[3354](BODY_FORCE_Z,0) = 0.000000; -NODES[3355](BODY_FORCE_X,0) = 0.000000; -NODES[3355](BODY_FORCE_Y,0) = -9.810000; -NODES[3355](BODY_FORCE_Z,0) = 0.000000; -NODES[3356](BODY_FORCE_X,0) = 0.000000; -NODES[3356](BODY_FORCE_Y,0) = -9.810000; -NODES[3356](BODY_FORCE_Z,0) = 0.000000; -NODES[3357](BODY_FORCE_X,0) = 0.000000; -NODES[3357](BODY_FORCE_Y,0) = -9.810000; -NODES[3357](BODY_FORCE_Z,0) = 0.000000; -NODES[3358](BODY_FORCE_X,0) = 0.000000; -NODES[3358](BODY_FORCE_Y,0) = -9.810000; -NODES[3358](BODY_FORCE_Z,0) = 0.000000; -NODES[3359](BODY_FORCE_X,0) = 0.000000; -NODES[3359](BODY_FORCE_Y,0) = -9.810000; -NODES[3359](BODY_FORCE_Z,0) = 0.000000; -NODES[3360](BODY_FORCE_X,0) = 0.000000; -NODES[3360](BODY_FORCE_Y,0) = -9.810000; -NODES[3360](BODY_FORCE_Z,0) = 0.000000; -NODES[3361](BODY_FORCE_X,0) = 0.000000; -NODES[3361](BODY_FORCE_Y,0) = -9.810000; -NODES[3361](BODY_FORCE_Z,0) = 0.000000; -NODES[3362](BODY_FORCE_X,0) = 0.000000; -NODES[3362](BODY_FORCE_Y,0) = -9.810000; -NODES[3362](BODY_FORCE_Z,0) = 0.000000; -NODES[3363](BODY_FORCE_X,0) = 0.000000; -NODES[3363](BODY_FORCE_Y,0) = -9.810000; -NODES[3363](BODY_FORCE_Z,0) = 0.000000; -NODES[3364](BODY_FORCE_X,0) = 0.000000; -NODES[3364](BODY_FORCE_Y,0) = -9.810000; -NODES[3364](BODY_FORCE_Z,0) = 0.000000; -NODES[3365](BODY_FORCE_X,0) = 0.000000; -NODES[3365](BODY_FORCE_Y,0) = -9.810000; -NODES[3365](BODY_FORCE_Z,0) = 0.000000; -NODES[3366](BODY_FORCE_X,0) = 0.000000; -NODES[3366](BODY_FORCE_Y,0) = -9.810000; -NODES[3366](BODY_FORCE_Z,0) = 0.000000; -NODES[3367](BODY_FORCE_X,0) = 0.000000; -NODES[3367](BODY_FORCE_Y,0) = -9.810000; -NODES[3367](BODY_FORCE_Z,0) = 0.000000; -NODES[3368](BODY_FORCE_X,0) = 0.000000; -NODES[3368](BODY_FORCE_Y,0) = -9.810000; -NODES[3368](BODY_FORCE_Z,0) = 0.000000; -NODES[3369](BODY_FORCE_X,0) = 0.000000; -NODES[3369](BODY_FORCE_Y,0) = -9.810000; -NODES[3369](BODY_FORCE_Z,0) = 0.000000; -NODES[3370](BODY_FORCE_X,0) = 0.000000; -NODES[3370](BODY_FORCE_Y,0) = -9.810000; -NODES[3370](BODY_FORCE_Z,0) = 0.000000; -NODES[3371](BODY_FORCE_X,0) = 0.000000; -NODES[3371](BODY_FORCE_Y,0) = -9.810000; -NODES[3371](BODY_FORCE_Z,0) = 0.000000; -NODES[3372](BODY_FORCE_X,0) = 0.000000; -NODES[3372](BODY_FORCE_Y,0) = -9.810000; -NODES[3372](BODY_FORCE_Z,0) = 0.000000; -NODES[3373](BODY_FORCE_X,0) = 0.000000; -NODES[3373](BODY_FORCE_Y,0) = -9.810000; -NODES[3373](BODY_FORCE_Z,0) = 0.000000; -NODES[3374](BODY_FORCE_X,0) = 0.000000; -NODES[3374](BODY_FORCE_Y,0) = -9.810000; -NODES[3374](BODY_FORCE_Z,0) = 0.000000; -NODES[3376](BODY_FORCE_X,0) = 0.000000; -NODES[3376](BODY_FORCE_Y,0) = -9.810000; -NODES[3376](BODY_FORCE_Z,0) = 0.000000; -NODES[3377](BODY_FORCE_X,0) = 0.000000; -NODES[3377](BODY_FORCE_Y,0) = -9.810000; -NODES[3377](BODY_FORCE_Z,0) = 0.000000; -NODES[3378](BODY_FORCE_X,0) = 0.000000; -NODES[3378](BODY_FORCE_Y,0) = -9.810000; -NODES[3378](BODY_FORCE_Z,0) = 0.000000; -NODES[3379](BODY_FORCE_X,0) = 0.000000; -NODES[3379](BODY_FORCE_Y,0) = -9.810000; -NODES[3379](BODY_FORCE_Z,0) = 0.000000; -NODES[3380](BODY_FORCE_X,0) = 0.000000; -NODES[3380](BODY_FORCE_Y,0) = -9.810000; -NODES[3380](BODY_FORCE_Z,0) = 0.000000; -NODES[3381](BODY_FORCE_X,0) = 0.000000; -NODES[3381](BODY_FORCE_Y,0) = -9.810000; -NODES[3381](BODY_FORCE_Z,0) = 0.000000; -NODES[3382](BODY_FORCE_X,0) = 0.000000; -NODES[3382](BODY_FORCE_Y,0) = -9.810000; -NODES[3382](BODY_FORCE_Z,0) = 0.000000; -NODES[3383](BODY_FORCE_X,0) = 0.000000; -NODES[3383](BODY_FORCE_Y,0) = -9.810000; -NODES[3383](BODY_FORCE_Z,0) = 0.000000; -NODES[3384](BODY_FORCE_X,0) = 0.000000; -NODES[3384](BODY_FORCE_Y,0) = -9.810000; -NODES[3384](BODY_FORCE_Z,0) = 0.000000; -NODES[3385](BODY_FORCE_X,0) = 0.000000; -NODES[3385](BODY_FORCE_Y,0) = -9.810000; -NODES[3385](BODY_FORCE_Z,0) = 0.000000; -NODES[3386](BODY_FORCE_X,0) = 0.000000; -NODES[3386](BODY_FORCE_Y,0) = -9.810000; -NODES[3386](BODY_FORCE_Z,0) = 0.000000; -NODES[3387](BODY_FORCE_X,0) = 0.000000; -NODES[3387](BODY_FORCE_Y,0) = -9.810000; -NODES[3387](BODY_FORCE_Z,0) = 0.000000; -NODES[3388](BODY_FORCE_X,0) = 0.000000; -NODES[3388](BODY_FORCE_Y,0) = -9.810000; -NODES[3388](BODY_FORCE_Z,0) = 0.000000; -NODES[3389](BODY_FORCE_X,0) = 0.000000; -NODES[3389](BODY_FORCE_Y,0) = -9.810000; -NODES[3389](BODY_FORCE_Z,0) = 0.000000; -NODES[3390](BODY_FORCE_X,0) = 0.000000; -NODES[3390](BODY_FORCE_Y,0) = -9.810000; -NODES[3390](BODY_FORCE_Z,0) = 0.000000; -NODES[3391](BODY_FORCE_X,0) = 0.000000; -NODES[3391](BODY_FORCE_Y,0) = -9.810000; -NODES[3391](BODY_FORCE_Z,0) = 0.000000; -NODES[3392](BODY_FORCE_X,0) = 0.000000; -NODES[3392](BODY_FORCE_Y,0) = -9.810000; -NODES[3392](BODY_FORCE_Z,0) = 0.000000; -NODES[3393](BODY_FORCE_X,0) = 0.000000; -NODES[3393](BODY_FORCE_Y,0) = -9.810000; -NODES[3393](BODY_FORCE_Z,0) = 0.000000; -NODES[3394](BODY_FORCE_X,0) = 0.000000; -NODES[3394](BODY_FORCE_Y,0) = -9.810000; -NODES[3394](BODY_FORCE_Z,0) = 0.000000; -NODES[3395](BODY_FORCE_X,0) = 0.000000; -NODES[3395](BODY_FORCE_Y,0) = -9.810000; -NODES[3395](BODY_FORCE_Z,0) = 0.000000; -NODES[3396](BODY_FORCE_X,0) = 0.000000; -NODES[3396](BODY_FORCE_Y,0) = -9.810000; -NODES[3396](BODY_FORCE_Z,0) = 0.000000; -NODES[3397](BODY_FORCE_X,0) = 0.000000; -NODES[3397](BODY_FORCE_Y,0) = -9.810000; -NODES[3397](BODY_FORCE_Z,0) = 0.000000; -NODES[3398](BODY_FORCE_X,0) = 0.000000; -NODES[3398](BODY_FORCE_Y,0) = -9.810000; -NODES[3398](BODY_FORCE_Z,0) = 0.000000; -NODES[3399](BODY_FORCE_X,0) = 0.000000; -NODES[3399](BODY_FORCE_Y,0) = -9.810000; -NODES[3399](BODY_FORCE_Z,0) = 0.000000; -NODES[3400](BODY_FORCE_X,0) = 0.000000; -NODES[3400](BODY_FORCE_Y,0) = -9.810000; -NODES[3400](BODY_FORCE_Z,0) = 0.000000; -NODES[3402](BODY_FORCE_X,0) = 0.000000; -NODES[3402](BODY_FORCE_Y,0) = -9.810000; -NODES[3402](BODY_FORCE_Z,0) = 0.000000; -NODES[3403](BODY_FORCE_X,0) = 0.000000; -NODES[3403](BODY_FORCE_Y,0) = -9.810000; -NODES[3403](BODY_FORCE_Z,0) = 0.000000; -NODES[3404](BODY_FORCE_X,0) = 0.000000; -NODES[3404](BODY_FORCE_Y,0) = -9.810000; -NODES[3404](BODY_FORCE_Z,0) = 0.000000; -NODES[3405](BODY_FORCE_X,0) = 0.000000; -NODES[3405](BODY_FORCE_Y,0) = -9.810000; -NODES[3405](BODY_FORCE_Z,0) = 0.000000; -NODES[3406](BODY_FORCE_X,0) = 0.000000; -NODES[3406](BODY_FORCE_Y,0) = -9.810000; -NODES[3406](BODY_FORCE_Z,0) = 0.000000; -NODES[3407](BODY_FORCE_X,0) = 0.000000; -NODES[3407](BODY_FORCE_Y,0) = -9.810000; -NODES[3407](BODY_FORCE_Z,0) = 0.000000; -NODES[3408](BODY_FORCE_X,0) = 0.000000; -NODES[3408](BODY_FORCE_Y,0) = -9.810000; -NODES[3408](BODY_FORCE_Z,0) = 0.000000; -NODES[3409](BODY_FORCE_X,0) = 0.000000; -NODES[3409](BODY_FORCE_Y,0) = -9.810000; -NODES[3409](BODY_FORCE_Z,0) = 0.000000; -NODES[3410](BODY_FORCE_X,0) = 0.000000; -NODES[3410](BODY_FORCE_Y,0) = -9.810000; -NODES[3410](BODY_FORCE_Z,0) = 0.000000; -NODES[3411](BODY_FORCE_X,0) = 0.000000; -NODES[3411](BODY_FORCE_Y,0) = -9.810000; -NODES[3411](BODY_FORCE_Z,0) = 0.000000; -NODES[3412](BODY_FORCE_X,0) = 0.000000; -NODES[3412](BODY_FORCE_Y,0) = -9.810000; -NODES[3412](BODY_FORCE_Z,0) = 0.000000; -NODES[3413](BODY_FORCE_X,0) = 0.000000; -NODES[3413](BODY_FORCE_Y,0) = -9.810000; -NODES[3413](BODY_FORCE_Z,0) = 0.000000; -NODES[3414](BODY_FORCE_X,0) = 0.000000; -NODES[3414](BODY_FORCE_Y,0) = -9.810000; -NODES[3414](BODY_FORCE_Z,0) = 0.000000; -NODES[3415](BODY_FORCE_X,0) = 0.000000; -NODES[3415](BODY_FORCE_Y,0) = -9.810000; -NODES[3415](BODY_FORCE_Z,0) = 0.000000; -NODES[3416](BODY_FORCE_X,0) = 0.000000; -NODES[3416](BODY_FORCE_Y,0) = -9.810000; -NODES[3416](BODY_FORCE_Z,0) = 0.000000; -NODES[3417](BODY_FORCE_X,0) = 0.000000; -NODES[3417](BODY_FORCE_Y,0) = -9.810000; -NODES[3417](BODY_FORCE_Z,0) = 0.000000; -NODES[3418](BODY_FORCE_X,0) = 0.000000; -NODES[3418](BODY_FORCE_Y,0) = -9.810000; -NODES[3418](BODY_FORCE_Z,0) = 0.000000; -NODES[3419](BODY_FORCE_X,0) = 0.000000; -NODES[3419](BODY_FORCE_Y,0) = -9.810000; -NODES[3419](BODY_FORCE_Z,0) = 0.000000; -NODES[3420](BODY_FORCE_X,0) = 0.000000; -NODES[3420](BODY_FORCE_Y,0) = -9.810000; -NODES[3420](BODY_FORCE_Z,0) = 0.000000; -NODES[3421](BODY_FORCE_X,0) = 0.000000; -NODES[3421](BODY_FORCE_Y,0) = -9.810000; -NODES[3421](BODY_FORCE_Z,0) = 0.000000; -NODES[3422](BODY_FORCE_X,0) = 0.000000; -NODES[3422](BODY_FORCE_Y,0) = -9.810000; -NODES[3422](BODY_FORCE_Z,0) = 0.000000; -NODES[3423](BODY_FORCE_X,0) = 0.000000; -NODES[3423](BODY_FORCE_Y,0) = -9.810000; -NODES[3423](BODY_FORCE_Z,0) = 0.000000; -NODES[3424](BODY_FORCE_X,0) = 0.000000; -NODES[3424](BODY_FORCE_Y,0) = -9.810000; -NODES[3424](BODY_FORCE_Z,0) = 0.000000; -NODES[3425](BODY_FORCE_X,0) = 0.000000; -NODES[3425](BODY_FORCE_Y,0) = -9.810000; -NODES[3425](BODY_FORCE_Z,0) = 0.000000; -NODES[3427](BODY_FORCE_X,0) = 0.000000; -NODES[3427](BODY_FORCE_Y,0) = -9.810000; -NODES[3427](BODY_FORCE_Z,0) = 0.000000; -NODES[3428](BODY_FORCE_X,0) = 0.000000; -NODES[3428](BODY_FORCE_Y,0) = -9.810000; -NODES[3428](BODY_FORCE_Z,0) = 0.000000; -NODES[3429](BODY_FORCE_X,0) = 0.000000; -NODES[3429](BODY_FORCE_Y,0) = -9.810000; -NODES[3429](BODY_FORCE_Z,0) = 0.000000; -NODES[3430](BODY_FORCE_X,0) = 0.000000; -NODES[3430](BODY_FORCE_Y,0) = -9.810000; -NODES[3430](BODY_FORCE_Z,0) = 0.000000; -NODES[3431](BODY_FORCE_X,0) = 0.000000; -NODES[3431](BODY_FORCE_Y,0) = -9.810000; -NODES[3431](BODY_FORCE_Z,0) = 0.000000; -NODES[3432](BODY_FORCE_X,0) = 0.000000; -NODES[3432](BODY_FORCE_Y,0) = -9.810000; -NODES[3432](BODY_FORCE_Z,0) = 0.000000; -NODES[3433](BODY_FORCE_X,0) = 0.000000; -NODES[3433](BODY_FORCE_Y,0) = -9.810000; -NODES[3433](BODY_FORCE_Z,0) = 0.000000; -NODES[3434](BODY_FORCE_X,0) = 0.000000; -NODES[3434](BODY_FORCE_Y,0) = -9.810000; -NODES[3434](BODY_FORCE_Z,0) = 0.000000; -NODES[3435](BODY_FORCE_X,0) = 0.000000; -NODES[3435](BODY_FORCE_Y,0) = -9.810000; -NODES[3435](BODY_FORCE_Z,0) = 0.000000; -NODES[3436](BODY_FORCE_X,0) = 0.000000; -NODES[3436](BODY_FORCE_Y,0) = -9.810000; -NODES[3436](BODY_FORCE_Z,0) = 0.000000; -NODES[3437](BODY_FORCE_X,0) = 0.000000; -NODES[3437](BODY_FORCE_Y,0) = -9.810000; -NODES[3437](BODY_FORCE_Z,0) = 0.000000; -NODES[3438](BODY_FORCE_X,0) = 0.000000; -NODES[3438](BODY_FORCE_Y,0) = -9.810000; -NODES[3438](BODY_FORCE_Z,0) = 0.000000; -NODES[3439](BODY_FORCE_X,0) = 0.000000; -NODES[3439](BODY_FORCE_Y,0) = -9.810000; -NODES[3439](BODY_FORCE_Z,0) = 0.000000; -NODES[3440](BODY_FORCE_X,0) = 0.000000; -NODES[3440](BODY_FORCE_Y,0) = -9.810000; -NODES[3440](BODY_FORCE_Z,0) = 0.000000; -NODES[3441](BODY_FORCE_X,0) = 0.000000; -NODES[3441](BODY_FORCE_Y,0) = -9.810000; -NODES[3441](BODY_FORCE_Z,0) = 0.000000; -NODES[3442](BODY_FORCE_X,0) = 0.000000; -NODES[3442](BODY_FORCE_Y,0) = -9.810000; -NODES[3442](BODY_FORCE_Z,0) = 0.000000; -NODES[3443](BODY_FORCE_X,0) = 0.000000; -NODES[3443](BODY_FORCE_Y,0) = -9.810000; -NODES[3443](BODY_FORCE_Z,0) = 0.000000; -NODES[3444](BODY_FORCE_X,0) = 0.000000; -NODES[3444](BODY_FORCE_Y,0) = -9.810000; -NODES[3444](BODY_FORCE_Z,0) = 0.000000; -NODES[3445](BODY_FORCE_X,0) = 0.000000; -NODES[3445](BODY_FORCE_Y,0) = -9.810000; -NODES[3445](BODY_FORCE_Z,0) = 0.000000; -NODES[3446](BODY_FORCE_X,0) = 0.000000; -NODES[3446](BODY_FORCE_Y,0) = -9.810000; -NODES[3446](BODY_FORCE_Z,0) = 0.000000; -NODES[3447](BODY_FORCE_X,0) = 0.000000; -NODES[3447](BODY_FORCE_Y,0) = -9.810000; -NODES[3447](BODY_FORCE_Z,0) = 0.000000; -NODES[3448](BODY_FORCE_X,0) = 0.000000; -NODES[3448](BODY_FORCE_Y,0) = -9.810000; -NODES[3448](BODY_FORCE_Z,0) = 0.000000; -NODES[3449](BODY_FORCE_X,0) = 0.000000; -NODES[3449](BODY_FORCE_Y,0) = -9.810000; -NODES[3449](BODY_FORCE_Z,0) = 0.000000; -NODES[3450](BODY_FORCE_X,0) = 0.000000; -NODES[3450](BODY_FORCE_Y,0) = -9.810000; -NODES[3450](BODY_FORCE_Z,0) = 0.000000; -NODES[3451](BODY_FORCE_X,0) = 0.000000; -NODES[3451](BODY_FORCE_Y,0) = -9.810000; -NODES[3451](BODY_FORCE_Z,0) = 0.000000; -NODES[3452](BODY_FORCE_X,0) = 0.000000; -NODES[3452](BODY_FORCE_Y,0) = -9.810000; -NODES[3452](BODY_FORCE_Z,0) = 0.000000; -NODES[3453](BODY_FORCE_X,0) = 0.000000; -NODES[3453](BODY_FORCE_Y,0) = -9.810000; -NODES[3453](BODY_FORCE_Z,0) = 0.000000; -NODES[3454](BODY_FORCE_X,0) = 0.000000; -NODES[3454](BODY_FORCE_Y,0) = -9.810000; -NODES[3454](BODY_FORCE_Z,0) = 0.000000; -NODES[3455](BODY_FORCE_X,0) = 0.000000; -NODES[3455](BODY_FORCE_Y,0) = -9.810000; -NODES[3455](BODY_FORCE_Z,0) = 0.000000; -NODES[3456](BODY_FORCE_X,0) = 0.000000; -NODES[3456](BODY_FORCE_Y,0) = -9.810000; -NODES[3456](BODY_FORCE_Z,0) = 0.000000; -NODES[3457](BODY_FORCE_X,0) = 0.000000; -NODES[3457](BODY_FORCE_Y,0) = -9.810000; -NODES[3457](BODY_FORCE_Z,0) = 0.000000; -NODES[3458](BODY_FORCE_X,0) = 0.000000; -NODES[3458](BODY_FORCE_Y,0) = -9.810000; -NODES[3458](BODY_FORCE_Z,0) = 0.000000; -NODES[3460](BODY_FORCE_X,0) = 0.000000; -NODES[3460](BODY_FORCE_Y,0) = -9.810000; -NODES[3460](BODY_FORCE_Z,0) = 0.000000; -NODES[3461](BODY_FORCE_X,0) = 0.000000; -NODES[3461](BODY_FORCE_Y,0) = -9.810000; -NODES[3461](BODY_FORCE_Z,0) = 0.000000; -NODES[3462](BODY_FORCE_X,0) = 0.000000; -NODES[3462](BODY_FORCE_Y,0) = -9.810000; -NODES[3462](BODY_FORCE_Z,0) = 0.000000; -NODES[3463](BODY_FORCE_X,0) = 0.000000; -NODES[3463](BODY_FORCE_Y,0) = -9.810000; -NODES[3463](BODY_FORCE_Z,0) = 0.000000; -NODES[3464](BODY_FORCE_X,0) = 0.000000; -NODES[3464](BODY_FORCE_Y,0) = -9.810000; -NODES[3464](BODY_FORCE_Z,0) = 0.000000; -NODES[3465](BODY_FORCE_X,0) = 0.000000; -NODES[3465](BODY_FORCE_Y,0) = -9.810000; -NODES[3465](BODY_FORCE_Z,0) = 0.000000; -NODES[3466](BODY_FORCE_X,0) = 0.000000; -NODES[3466](BODY_FORCE_Y,0) = -9.810000; -NODES[3466](BODY_FORCE_Z,0) = 0.000000; -NODES[3467](BODY_FORCE_X,0) = 0.000000; -NODES[3467](BODY_FORCE_Y,0) = -9.810000; -NODES[3467](BODY_FORCE_Z,0) = 0.000000; -NODES[3468](BODY_FORCE_X,0) = 0.000000; -NODES[3468](BODY_FORCE_Y,0) = -9.810000; -NODES[3468](BODY_FORCE_Z,0) = 0.000000; -NODES[3469](BODY_FORCE_X,0) = 0.000000; -NODES[3469](BODY_FORCE_Y,0) = -9.810000; -NODES[3469](BODY_FORCE_Z,0) = 0.000000; -NODES[3470](BODY_FORCE_X,0) = 0.000000; -NODES[3470](BODY_FORCE_Y,0) = -9.810000; -NODES[3470](BODY_FORCE_Z,0) = 0.000000; -NODES[3471](BODY_FORCE_X,0) = 0.000000; -NODES[3471](BODY_FORCE_Y,0) = -9.810000; -NODES[3471](BODY_FORCE_Z,0) = 0.000000; -NODES[3472](BODY_FORCE_X,0) = 0.000000; -NODES[3472](BODY_FORCE_Y,0) = -9.810000; -NODES[3472](BODY_FORCE_Z,0) = 0.000000; -NODES[3473](BODY_FORCE_X,0) = 0.000000; -NODES[3473](BODY_FORCE_Y,0) = -9.810000; -NODES[3473](BODY_FORCE_Z,0) = 0.000000; -NODES[3474](BODY_FORCE_X,0) = 0.000000; -NODES[3474](BODY_FORCE_Y,0) = -9.810000; -NODES[3474](BODY_FORCE_Z,0) = 0.000000; -NODES[3475](BODY_FORCE_X,0) = 0.000000; -NODES[3475](BODY_FORCE_Y,0) = -9.810000; -NODES[3475](BODY_FORCE_Z,0) = 0.000000; -NODES[3476](BODY_FORCE_X,0) = 0.000000; -NODES[3476](BODY_FORCE_Y,0) = -9.810000; -NODES[3476](BODY_FORCE_Z,0) = 0.000000; -NODES[3477](BODY_FORCE_X,0) = 0.000000; -NODES[3477](BODY_FORCE_Y,0) = -9.810000; -NODES[3477](BODY_FORCE_Z,0) = 0.000000; -NODES[3478](BODY_FORCE_X,0) = 0.000000; -NODES[3478](BODY_FORCE_Y,0) = -9.810000; -NODES[3478](BODY_FORCE_Z,0) = 0.000000; -NODES[3479](BODY_FORCE_X,0) = 0.000000; -NODES[3479](BODY_FORCE_Y,0) = -9.810000; -NODES[3479](BODY_FORCE_Z,0) = 0.000000; -NODES[3480](BODY_FORCE_X,0) = 0.000000; -NODES[3480](BODY_FORCE_Y,0) = -9.810000; -NODES[3480](BODY_FORCE_Z,0) = 0.000000; -NODES[3481](BODY_FORCE_X,0) = 0.000000; -NODES[3481](BODY_FORCE_Y,0) = -9.810000; -NODES[3481](BODY_FORCE_Z,0) = 0.000000; -NODES[3482](BODY_FORCE_X,0) = 0.000000; -NODES[3482](BODY_FORCE_Y,0) = -9.810000; -NODES[3482](BODY_FORCE_Z,0) = 0.000000; -NODES[3483](BODY_FORCE_X,0) = 0.000000; -NODES[3483](BODY_FORCE_Y,0) = -9.810000; -NODES[3483](BODY_FORCE_Z,0) = 0.000000; -NODES[3484](BODY_FORCE_X,0) = 0.000000; -NODES[3484](BODY_FORCE_Y,0) = -9.810000; -NODES[3484](BODY_FORCE_Z,0) = 0.000000; -NODES[3486](BODY_FORCE_X,0) = 0.000000; -NODES[3486](BODY_FORCE_Y,0) = -9.810000; -NODES[3486](BODY_FORCE_Z,0) = 0.000000; -NODES[3487](BODY_FORCE_X,0) = 0.000000; -NODES[3487](BODY_FORCE_Y,0) = -9.810000; -NODES[3487](BODY_FORCE_Z,0) = 0.000000; -NODES[3488](BODY_FORCE_X,0) = 0.000000; -NODES[3488](BODY_FORCE_Y,0) = -9.810000; -NODES[3488](BODY_FORCE_Z,0) = 0.000000; -NODES[3489](BODY_FORCE_X,0) = 0.000000; -NODES[3489](BODY_FORCE_Y,0) = -9.810000; -NODES[3489](BODY_FORCE_Z,0) = 0.000000; -NODES[3490](BODY_FORCE_X,0) = 0.000000; -NODES[3490](BODY_FORCE_Y,0) = -9.810000; -NODES[3490](BODY_FORCE_Z,0) = 0.000000; -NODES[3491](BODY_FORCE_X,0) = 0.000000; -NODES[3491](BODY_FORCE_Y,0) = -9.810000; -NODES[3491](BODY_FORCE_Z,0) = 0.000000; -NODES[3492](BODY_FORCE_X,0) = 0.000000; -NODES[3492](BODY_FORCE_Y,0) = -9.810000; -NODES[3492](BODY_FORCE_Z,0) = 0.000000; -NODES[3493](BODY_FORCE_X,0) = 0.000000; -NODES[3493](BODY_FORCE_Y,0) = -9.810000; -NODES[3493](BODY_FORCE_Z,0) = 0.000000; -NODES[3494](BODY_FORCE_X,0) = 0.000000; -NODES[3494](BODY_FORCE_Y,0) = -9.810000; -NODES[3494](BODY_FORCE_Z,0) = 0.000000; -NODES[3495](BODY_FORCE_X,0) = 0.000000; -NODES[3495](BODY_FORCE_Y,0) = -9.810000; -NODES[3495](BODY_FORCE_Z,0) = 0.000000; -NODES[3496](BODY_FORCE_X,0) = 0.000000; -NODES[3496](BODY_FORCE_Y,0) = -9.810000; -NODES[3496](BODY_FORCE_Z,0) = 0.000000; -NODES[3497](BODY_FORCE_X,0) = 0.000000; -NODES[3497](BODY_FORCE_Y,0) = -9.810000; -NODES[3497](BODY_FORCE_Z,0) = 0.000000; -NODES[3498](BODY_FORCE_X,0) = 0.000000; -NODES[3498](BODY_FORCE_Y,0) = -9.810000; -NODES[3498](BODY_FORCE_Z,0) = 0.000000; -NODES[3499](BODY_FORCE_X,0) = 0.000000; -NODES[3499](BODY_FORCE_Y,0) = -9.810000; -NODES[3499](BODY_FORCE_Z,0) = 0.000000; -NODES[3500](BODY_FORCE_X,0) = 0.000000; -NODES[3500](BODY_FORCE_Y,0) = -9.810000; -NODES[3500](BODY_FORCE_Z,0) = 0.000000; -NODES[3501](BODY_FORCE_X,0) = 0.000000; -NODES[3501](BODY_FORCE_Y,0) = -9.810000; -NODES[3501](BODY_FORCE_Z,0) = 0.000000; -NODES[3502](BODY_FORCE_X,0) = 0.000000; -NODES[3502](BODY_FORCE_Y,0) = -9.810000; -NODES[3502](BODY_FORCE_Z,0) = 0.000000; -NODES[3503](BODY_FORCE_X,0) = 0.000000; -NODES[3503](BODY_FORCE_Y,0) = -9.810000; -NODES[3503](BODY_FORCE_Z,0) = 0.000000; -NODES[3504](BODY_FORCE_X,0) = 0.000000; -NODES[3504](BODY_FORCE_Y,0) = -9.810000; -NODES[3504](BODY_FORCE_Z,0) = 0.000000; -NODES[3505](BODY_FORCE_X,0) = 0.000000; -NODES[3505](BODY_FORCE_Y,0) = -9.810000; -NODES[3505](BODY_FORCE_Z,0) = 0.000000; -NODES[3506](BODY_FORCE_X,0) = 0.000000; -NODES[3506](BODY_FORCE_Y,0) = -9.810000; -NODES[3506](BODY_FORCE_Z,0) = 0.000000; -NODES[3507](BODY_FORCE_X,0) = 0.000000; -NODES[3507](BODY_FORCE_Y,0) = -9.810000; -NODES[3507](BODY_FORCE_Z,0) = 0.000000; -NODES[3508](BODY_FORCE_X,0) = 0.000000; -NODES[3508](BODY_FORCE_Y,0) = -9.810000; -NODES[3508](BODY_FORCE_Z,0) = 0.000000; -NODES[3509](BODY_FORCE_X,0) = 0.000000; -NODES[3509](BODY_FORCE_Y,0) = -9.810000; -NODES[3509](BODY_FORCE_Z,0) = 0.000000; -NODES[3510](BODY_FORCE_X,0) = 0.000000; -NODES[3510](BODY_FORCE_Y,0) = -9.810000; -NODES[3510](BODY_FORCE_Z,0) = 0.000000; -NODES[3511](BODY_FORCE_X,0) = 0.000000; -NODES[3511](BODY_FORCE_Y,0) = -9.810000; -NODES[3511](BODY_FORCE_Z,0) = 0.000000; -NODES[3513](BODY_FORCE_X,0) = 0.000000; -NODES[3513](BODY_FORCE_Y,0) = -9.810000; -NODES[3513](BODY_FORCE_Z,0) = 0.000000; -NODES[3514](BODY_FORCE_X,0) = 0.000000; -NODES[3514](BODY_FORCE_Y,0) = -9.810000; -NODES[3514](BODY_FORCE_Z,0) = 0.000000; -NODES[3515](BODY_FORCE_X,0) = 0.000000; -NODES[3515](BODY_FORCE_Y,0) = -9.810000; -NODES[3515](BODY_FORCE_Z,0) = 0.000000; -NODES[3516](BODY_FORCE_X,0) = 0.000000; -NODES[3516](BODY_FORCE_Y,0) = -9.810000; -NODES[3516](BODY_FORCE_Z,0) = 0.000000; -NODES[3517](BODY_FORCE_X,0) = 0.000000; -NODES[3517](BODY_FORCE_Y,0) = -9.810000; -NODES[3517](BODY_FORCE_Z,0) = 0.000000; -NODES[3518](BODY_FORCE_X,0) = 0.000000; -NODES[3518](BODY_FORCE_Y,0) = -9.810000; -NODES[3518](BODY_FORCE_Z,0) = 0.000000; -NODES[3519](BODY_FORCE_X,0) = 0.000000; -NODES[3519](BODY_FORCE_Y,0) = -9.810000; -NODES[3519](BODY_FORCE_Z,0) = 0.000000; -NODES[3520](BODY_FORCE_X,0) = 0.000000; -NODES[3520](BODY_FORCE_Y,0) = -9.810000; -NODES[3520](BODY_FORCE_Z,0) = 0.000000; -NODES[3521](BODY_FORCE_X,0) = 0.000000; -NODES[3521](BODY_FORCE_Y,0) = -9.810000; -NODES[3521](BODY_FORCE_Z,0) = 0.000000; -NODES[3522](BODY_FORCE_X,0) = 0.000000; -NODES[3522](BODY_FORCE_Y,0) = -9.810000; -NODES[3522](BODY_FORCE_Z,0) = 0.000000; -NODES[3523](BODY_FORCE_X,0) = 0.000000; -NODES[3523](BODY_FORCE_Y,0) = -9.810000; -NODES[3523](BODY_FORCE_Z,0) = 0.000000; -NODES[3524](BODY_FORCE_X,0) = 0.000000; -NODES[3524](BODY_FORCE_Y,0) = -9.810000; -NODES[3524](BODY_FORCE_Z,0) = 0.000000; -NODES[3525](BODY_FORCE_X,0) = 0.000000; -NODES[3525](BODY_FORCE_Y,0) = -9.810000; -NODES[3525](BODY_FORCE_Z,0) = 0.000000; -NODES[3526](BODY_FORCE_X,0) = 0.000000; -NODES[3526](BODY_FORCE_Y,0) = -9.810000; -NODES[3526](BODY_FORCE_Z,0) = 0.000000; -NODES[3527](BODY_FORCE_X,0) = 0.000000; -NODES[3527](BODY_FORCE_Y,0) = -9.810000; -NODES[3527](BODY_FORCE_Z,0) = 0.000000; -NODES[3528](BODY_FORCE_X,0) = 0.000000; -NODES[3528](BODY_FORCE_Y,0) = -9.810000; -NODES[3528](BODY_FORCE_Z,0) = 0.000000; -NODES[3529](BODY_FORCE_X,0) = 0.000000; -NODES[3529](BODY_FORCE_Y,0) = -9.810000; -NODES[3529](BODY_FORCE_Z,0) = 0.000000; -NODES[3530](BODY_FORCE_X,0) = 0.000000; -NODES[3530](BODY_FORCE_Y,0) = -9.810000; -NODES[3530](BODY_FORCE_Z,0) = 0.000000; -NODES[3531](BODY_FORCE_X,0) = 0.000000; -NODES[3531](BODY_FORCE_Y,0) = -9.810000; -NODES[3531](BODY_FORCE_Z,0) = 0.000000; -NODES[3532](BODY_FORCE_X,0) = 0.000000; -NODES[3532](BODY_FORCE_Y,0) = -9.810000; -NODES[3532](BODY_FORCE_Z,0) = 0.000000; -NODES[3533](BODY_FORCE_X,0) = 0.000000; -NODES[3533](BODY_FORCE_Y,0) = -9.810000; -NODES[3533](BODY_FORCE_Z,0) = 0.000000; -NODES[3534](BODY_FORCE_X,0) = 0.000000; -NODES[3534](BODY_FORCE_Y,0) = -9.810000; -NODES[3534](BODY_FORCE_Z,0) = 0.000000; -NODES[3535](BODY_FORCE_X,0) = 0.000000; -NODES[3535](BODY_FORCE_Y,0) = -9.810000; -NODES[3535](BODY_FORCE_Z,0) = 0.000000; -NODES[3536](BODY_FORCE_X,0) = 0.000000; -NODES[3536](BODY_FORCE_Y,0) = -9.810000; -NODES[3536](BODY_FORCE_Z,0) = 0.000000; -NODES[3537](BODY_FORCE_X,0) = 0.000000; -NODES[3537](BODY_FORCE_Y,0) = -9.810000; -NODES[3537](BODY_FORCE_Z,0) = 0.000000; -NODES[3539](BODY_FORCE_X,0) = 0.000000; -NODES[3539](BODY_FORCE_Y,0) = -9.810000; -NODES[3539](BODY_FORCE_Z,0) = 0.000000; -NODES[3540](BODY_FORCE_X,0) = 0.000000; -NODES[3540](BODY_FORCE_Y,0) = -9.810000; -NODES[3540](BODY_FORCE_Z,0) = 0.000000; -NODES[3541](BODY_FORCE_X,0) = 0.000000; -NODES[3541](BODY_FORCE_Y,0) = -9.810000; -NODES[3541](BODY_FORCE_Z,0) = 0.000000; -NODES[3542](BODY_FORCE_X,0) = 0.000000; -NODES[3542](BODY_FORCE_Y,0) = -9.810000; -NODES[3542](BODY_FORCE_Z,0) = 0.000000; -NODES[3543](BODY_FORCE_X,0) = 0.000000; -NODES[3543](BODY_FORCE_Y,0) = -9.810000; -NODES[3543](BODY_FORCE_Z,0) = 0.000000; -NODES[3544](BODY_FORCE_X,0) = 0.000000; -NODES[3544](BODY_FORCE_Y,0) = -9.810000; -NODES[3544](BODY_FORCE_Z,0) = 0.000000; -NODES[3545](BODY_FORCE_X,0) = 0.000000; -NODES[3545](BODY_FORCE_Y,0) = -9.810000; -NODES[3545](BODY_FORCE_Z,0) = 0.000000; -NODES[3546](BODY_FORCE_X,0) = 0.000000; -NODES[3546](BODY_FORCE_Y,0) = -9.810000; -NODES[3546](BODY_FORCE_Z,0) = 0.000000; -NODES[3547](BODY_FORCE_X,0) = 0.000000; -NODES[3547](BODY_FORCE_Y,0) = -9.810000; -NODES[3547](BODY_FORCE_Z,0) = 0.000000; -NODES[3548](BODY_FORCE_X,0) = 0.000000; -NODES[3548](BODY_FORCE_Y,0) = -9.810000; -NODES[3548](BODY_FORCE_Z,0) = 0.000000; -NODES[3549](BODY_FORCE_X,0) = 0.000000; -NODES[3549](BODY_FORCE_Y,0) = -9.810000; -NODES[3549](BODY_FORCE_Z,0) = 0.000000; -NODES[3550](BODY_FORCE_X,0) = 0.000000; -NODES[3550](BODY_FORCE_Y,0) = -9.810000; -NODES[3550](BODY_FORCE_Z,0) = 0.000000; -NODES[3551](BODY_FORCE_X,0) = 0.000000; -NODES[3551](BODY_FORCE_Y,0) = -9.810000; -NODES[3551](BODY_FORCE_Z,0) = 0.000000; -NODES[3552](BODY_FORCE_X,0) = 0.000000; -NODES[3552](BODY_FORCE_Y,0) = -9.810000; -NODES[3552](BODY_FORCE_Z,0) = 0.000000; -NODES[3553](BODY_FORCE_X,0) = 0.000000; -NODES[3553](BODY_FORCE_Y,0) = -9.810000; -NODES[3553](BODY_FORCE_Z,0) = 0.000000; -NODES[3554](BODY_FORCE_X,0) = 0.000000; -NODES[3554](BODY_FORCE_Y,0) = -9.810000; -NODES[3554](BODY_FORCE_Z,0) = 0.000000; -NODES[3555](BODY_FORCE_X,0) = 0.000000; -NODES[3555](BODY_FORCE_Y,0) = -9.810000; -NODES[3555](BODY_FORCE_Z,0) = 0.000000; -NODES[3556](BODY_FORCE_X,0) = 0.000000; -NODES[3556](BODY_FORCE_Y,0) = -9.810000; -NODES[3556](BODY_FORCE_Z,0) = 0.000000; -NODES[3557](BODY_FORCE_X,0) = 0.000000; -NODES[3557](BODY_FORCE_Y,0) = -9.810000; -NODES[3557](BODY_FORCE_Z,0) = 0.000000; -NODES[3558](BODY_FORCE_X,0) = 0.000000; -NODES[3558](BODY_FORCE_Y,0) = -9.810000; -NODES[3558](BODY_FORCE_Z,0) = 0.000000; -NODES[3559](BODY_FORCE_X,0) = 0.000000; -NODES[3559](BODY_FORCE_Y,0) = -9.810000; -NODES[3559](BODY_FORCE_Z,0) = 0.000000; -NODES[3560](BODY_FORCE_X,0) = 0.000000; -NODES[3560](BODY_FORCE_Y,0) = -9.810000; -NODES[3560](BODY_FORCE_Z,0) = 0.000000; -NODES[3561](BODY_FORCE_X,0) = 0.000000; -NODES[3561](BODY_FORCE_Y,0) = -9.810000; -NODES[3561](BODY_FORCE_Z,0) = 0.000000; -NODES[3562](BODY_FORCE_X,0) = 0.000000; -NODES[3562](BODY_FORCE_Y,0) = -9.810000; -NODES[3562](BODY_FORCE_Z,0) = 0.000000; -NODES[3564](BODY_FORCE_X,0) = 0.000000; -NODES[3564](BODY_FORCE_Y,0) = -9.810000; -NODES[3564](BODY_FORCE_Z,0) = 0.000000; -NODES[3565](BODY_FORCE_X,0) = 0.000000; -NODES[3565](BODY_FORCE_Y,0) = -9.810000; -NODES[3565](BODY_FORCE_Z,0) = 0.000000; -NODES[3566](BODY_FORCE_X,0) = 0.000000; -NODES[3566](BODY_FORCE_Y,0) = -9.810000; -NODES[3566](BODY_FORCE_Z,0) = 0.000000; -NODES[3567](BODY_FORCE_X,0) = 0.000000; -NODES[3567](BODY_FORCE_Y,0) = -9.810000; -NODES[3567](BODY_FORCE_Z,0) = 0.000000; -NODES[3568](BODY_FORCE_X,0) = 0.000000; -NODES[3568](BODY_FORCE_Y,0) = -9.810000; -NODES[3568](BODY_FORCE_Z,0) = 0.000000; -NODES[3569](BODY_FORCE_X,0) = 0.000000; -NODES[3569](BODY_FORCE_Y,0) = -9.810000; -NODES[3569](BODY_FORCE_Z,0) = 0.000000; -NODES[3570](BODY_FORCE_X,0) = 0.000000; -NODES[3570](BODY_FORCE_Y,0) = -9.810000; -NODES[3570](BODY_FORCE_Z,0) = 0.000000; -NODES[3571](BODY_FORCE_X,0) = 0.000000; -NODES[3571](BODY_FORCE_Y,0) = -9.810000; -NODES[3571](BODY_FORCE_Z,0) = 0.000000; -NODES[3572](BODY_FORCE_X,0) = 0.000000; -NODES[3572](BODY_FORCE_Y,0) = -9.810000; -NODES[3572](BODY_FORCE_Z,0) = 0.000000; -NODES[3573](BODY_FORCE_X,0) = 0.000000; -NODES[3573](BODY_FORCE_Y,0) = -9.810000; -NODES[3573](BODY_FORCE_Z,0) = 0.000000; -NODES[3574](BODY_FORCE_X,0) = 0.000000; -NODES[3574](BODY_FORCE_Y,0) = -9.810000; -NODES[3574](BODY_FORCE_Z,0) = 0.000000; -NODES[3575](BODY_FORCE_X,0) = 0.000000; -NODES[3575](BODY_FORCE_Y,0) = -9.810000; -NODES[3575](BODY_FORCE_Z,0) = 0.000000; -NODES[3576](BODY_FORCE_X,0) = 0.000000; -NODES[3576](BODY_FORCE_Y,0) = -9.810000; -NODES[3576](BODY_FORCE_Z,0) = 0.000000; -NODES[3577](BODY_FORCE_X,0) = 0.000000; -NODES[3577](BODY_FORCE_Y,0) = -9.810000; -NODES[3577](BODY_FORCE_Z,0) = 0.000000; -NODES[3578](BODY_FORCE_X,0) = 0.000000; -NODES[3578](BODY_FORCE_Y,0) = -9.810000; -NODES[3578](BODY_FORCE_Z,0) = 0.000000; -NODES[3579](BODY_FORCE_X,0) = 0.000000; -NODES[3579](BODY_FORCE_Y,0) = -9.810000; -NODES[3579](BODY_FORCE_Z,0) = 0.000000; -NODES[3580](BODY_FORCE_X,0) = 0.000000; -NODES[3580](BODY_FORCE_Y,0) = -9.810000; -NODES[3580](BODY_FORCE_Z,0) = 0.000000; -NODES[3581](BODY_FORCE_X,0) = 0.000000; -NODES[3581](BODY_FORCE_Y,0) = -9.810000; -NODES[3581](BODY_FORCE_Z,0) = 0.000000; -NODES[3582](BODY_FORCE_X,0) = 0.000000; -NODES[3582](BODY_FORCE_Y,0) = -9.810000; -NODES[3582](BODY_FORCE_Z,0) = 0.000000; -NODES[3583](BODY_FORCE_X,0) = 0.000000; -NODES[3583](BODY_FORCE_Y,0) = -9.810000; -NODES[3583](BODY_FORCE_Z,0) = 0.000000; -NODES[3584](BODY_FORCE_X,0) = 0.000000; -NODES[3584](BODY_FORCE_Y,0) = -9.810000; -NODES[3584](BODY_FORCE_Z,0) = 0.000000; -NODES[3585](BODY_FORCE_X,0) = 0.000000; -NODES[3585](BODY_FORCE_Y,0) = -9.810000; -NODES[3585](BODY_FORCE_Z,0) = 0.000000; -NODES[3586](BODY_FORCE_X,0) = 0.000000; -NODES[3586](BODY_FORCE_Y,0) = -9.810000; -NODES[3586](BODY_FORCE_Z,0) = 0.000000; -NODES[3588](BODY_FORCE_X,0) = 0.000000; -NODES[3588](BODY_FORCE_Y,0) = -9.810000; -NODES[3588](BODY_FORCE_Z,0) = 0.000000; -NODES[3589](BODY_FORCE_X,0) = 0.000000; -NODES[3589](BODY_FORCE_Y,0) = -9.810000; -NODES[3589](BODY_FORCE_Z,0) = 0.000000; -NODES[3590](BODY_FORCE_X,0) = 0.000000; -NODES[3590](BODY_FORCE_Y,0) = -9.810000; -NODES[3590](BODY_FORCE_Z,0) = 0.000000; -NODES[3591](BODY_FORCE_X,0) = 0.000000; -NODES[3591](BODY_FORCE_Y,0) = -9.810000; -NODES[3591](BODY_FORCE_Z,0) = 0.000000; -NODES[3592](BODY_FORCE_X,0) = 0.000000; -NODES[3592](BODY_FORCE_Y,0) = -9.810000; -NODES[3592](BODY_FORCE_Z,0) = 0.000000; -NODES[3593](BODY_FORCE_X,0) = 0.000000; -NODES[3593](BODY_FORCE_Y,0) = -9.810000; -NODES[3593](BODY_FORCE_Z,0) = 0.000000; -NODES[3594](BODY_FORCE_X,0) = 0.000000; -NODES[3594](BODY_FORCE_Y,0) = -9.810000; -NODES[3594](BODY_FORCE_Z,0) = 0.000000; -NODES[3595](BODY_FORCE_X,0) = 0.000000; -NODES[3595](BODY_FORCE_Y,0) = -9.810000; -NODES[3595](BODY_FORCE_Z,0) = 0.000000; -NODES[3596](BODY_FORCE_X,0) = 0.000000; -NODES[3596](BODY_FORCE_Y,0) = -9.810000; -NODES[3596](BODY_FORCE_Z,0) = 0.000000; -NODES[3597](BODY_FORCE_X,0) = 0.000000; -NODES[3597](BODY_FORCE_Y,0) = -9.810000; -NODES[3597](BODY_FORCE_Z,0) = 0.000000; -NODES[3598](BODY_FORCE_X,0) = 0.000000; -NODES[3598](BODY_FORCE_Y,0) = -9.810000; -NODES[3598](BODY_FORCE_Z,0) = 0.000000; -NODES[3599](BODY_FORCE_X,0) = 0.000000; -NODES[3599](BODY_FORCE_Y,0) = -9.810000; -NODES[3599](BODY_FORCE_Z,0) = 0.000000; -NODES[3600](BODY_FORCE_X,0) = 0.000000; -NODES[3600](BODY_FORCE_Y,0) = -9.810000; -NODES[3600](BODY_FORCE_Z,0) = 0.000000; -NODES[3601](BODY_FORCE_X,0) = 0.000000; -NODES[3601](BODY_FORCE_Y,0) = -9.810000; -NODES[3601](BODY_FORCE_Z,0) = 0.000000; -NODES[3602](BODY_FORCE_X,0) = 0.000000; -NODES[3602](BODY_FORCE_Y,0) = -9.810000; -NODES[3602](BODY_FORCE_Z,0) = 0.000000; -NODES[3603](BODY_FORCE_X,0) = 0.000000; -NODES[3603](BODY_FORCE_Y,0) = -9.810000; -NODES[3603](BODY_FORCE_Z,0) = 0.000000; -NODES[3604](BODY_FORCE_X,0) = 0.000000; -NODES[3604](BODY_FORCE_Y,0) = -9.810000; -NODES[3604](BODY_FORCE_Z,0) = 0.000000; -NODES[3605](BODY_FORCE_X,0) = 0.000000; -NODES[3605](BODY_FORCE_Y,0) = -9.810000; -NODES[3605](BODY_FORCE_Z,0) = 0.000000; -NODES[3606](BODY_FORCE_X,0) = 0.000000; -NODES[3606](BODY_FORCE_Y,0) = -9.810000; -NODES[3606](BODY_FORCE_Z,0) = 0.000000; -NODES[3607](BODY_FORCE_X,0) = 0.000000; -NODES[3607](BODY_FORCE_Y,0) = -9.810000; -NODES[3607](BODY_FORCE_Z,0) = 0.000000; -NODES[3608](BODY_FORCE_X,0) = 0.000000; -NODES[3608](BODY_FORCE_Y,0) = -9.810000; -NODES[3608](BODY_FORCE_Z,0) = 0.000000; -NODES[3609](BODY_FORCE_X,0) = 0.000000; -NODES[3609](BODY_FORCE_Y,0) = -9.810000; -NODES[3609](BODY_FORCE_Z,0) = 0.000000; -NODES[3610](BODY_FORCE_X,0) = 0.000000; -NODES[3610](BODY_FORCE_Y,0) = -9.810000; -NODES[3610](BODY_FORCE_Z,0) = 0.000000; -NODES[3611](BODY_FORCE_X,0) = 0.000000; -NODES[3611](BODY_FORCE_Y,0) = -9.810000; -NODES[3611](BODY_FORCE_Z,0) = 0.000000; -NODES[3612](BODY_FORCE_X,0) = 0.000000; -NODES[3612](BODY_FORCE_Y,0) = -9.810000; -NODES[3612](BODY_FORCE_Z,0) = 0.000000; -NODES[3613](BODY_FORCE_X,0) = 0.000000; -NODES[3613](BODY_FORCE_Y,0) = -9.810000; -NODES[3613](BODY_FORCE_Z,0) = 0.000000; -NODES[3614](BODY_FORCE_X,0) = 0.000000; -NODES[3614](BODY_FORCE_Y,0) = -9.810000; -NODES[3614](BODY_FORCE_Z,0) = 0.000000; -NODES[3615](BODY_FORCE_X,0) = 0.000000; -NODES[3615](BODY_FORCE_Y,0) = -9.810000; -NODES[3615](BODY_FORCE_Z,0) = 0.000000; -NODES[3616](BODY_FORCE_X,0) = 0.000000; -NODES[3616](BODY_FORCE_Y,0) = -9.810000; -NODES[3616](BODY_FORCE_Z,0) = 0.000000; -NODES[3618](BODY_FORCE_X,0) = 0.000000; -NODES[3618](BODY_FORCE_Y,0) = -9.810000; -NODES[3618](BODY_FORCE_Z,0) = 0.000000; -NODES[3619](BODY_FORCE_X,0) = 0.000000; -NODES[3619](BODY_FORCE_Y,0) = -9.810000; -NODES[3619](BODY_FORCE_Z,0) = 0.000000; -NODES[3620](BODY_FORCE_X,0) = 0.000000; -NODES[3620](BODY_FORCE_Y,0) = -9.810000; -NODES[3620](BODY_FORCE_Z,0) = 0.000000; -NODES[3621](BODY_FORCE_X,0) = 0.000000; -NODES[3621](BODY_FORCE_Y,0) = -9.810000; -NODES[3621](BODY_FORCE_Z,0) = 0.000000; -NODES[3622](BODY_FORCE_X,0) = 0.000000; -NODES[3622](BODY_FORCE_Y,0) = -9.810000; -NODES[3622](BODY_FORCE_Z,0) = 0.000000; -NODES[3623](BODY_FORCE_X,0) = 0.000000; -NODES[3623](BODY_FORCE_Y,0) = -9.810000; -NODES[3623](BODY_FORCE_Z,0) = 0.000000; -NODES[3624](BODY_FORCE_X,0) = 0.000000; -NODES[3624](BODY_FORCE_Y,0) = -9.810000; -NODES[3624](BODY_FORCE_Z,0) = 0.000000; -NODES[3625](BODY_FORCE_X,0) = 0.000000; -NODES[3625](BODY_FORCE_Y,0) = -9.810000; -NODES[3625](BODY_FORCE_Z,0) = 0.000000; -NODES[3626](BODY_FORCE_X,0) = 0.000000; -NODES[3626](BODY_FORCE_Y,0) = -9.810000; -NODES[3626](BODY_FORCE_Z,0) = 0.000000; -NODES[3627](BODY_FORCE_X,0) = 0.000000; -NODES[3627](BODY_FORCE_Y,0) = -9.810000; -NODES[3627](BODY_FORCE_Z,0) = 0.000000; -NODES[3628](BODY_FORCE_X,0) = 0.000000; -NODES[3628](BODY_FORCE_Y,0) = -9.810000; -NODES[3628](BODY_FORCE_Z,0) = 0.000000; -NODES[3629](BODY_FORCE_X,0) = 0.000000; -NODES[3629](BODY_FORCE_Y,0) = -9.810000; -NODES[3629](BODY_FORCE_Z,0) = 0.000000; -NODES[3630](BODY_FORCE_X,0) = 0.000000; -NODES[3630](BODY_FORCE_Y,0) = -9.810000; -NODES[3630](BODY_FORCE_Z,0) = 0.000000; -NODES[3631](BODY_FORCE_X,0) = 0.000000; -NODES[3631](BODY_FORCE_Y,0) = -9.810000; -NODES[3631](BODY_FORCE_Z,0) = 0.000000; -NODES[3632](BODY_FORCE_X,0) = 0.000000; -NODES[3632](BODY_FORCE_Y,0) = -9.810000; -NODES[3632](BODY_FORCE_Z,0) = 0.000000; -NODES[3633](BODY_FORCE_X,0) = 0.000000; -NODES[3633](BODY_FORCE_Y,0) = -9.810000; -NODES[3633](BODY_FORCE_Z,0) = 0.000000; -NODES[3634](BODY_FORCE_X,0) = 0.000000; -NODES[3634](BODY_FORCE_Y,0) = -9.810000; -NODES[3634](BODY_FORCE_Z,0) = 0.000000; -NODES[3635](BODY_FORCE_X,0) = 0.000000; -NODES[3635](BODY_FORCE_Y,0) = -9.810000; -NODES[3635](BODY_FORCE_Z,0) = 0.000000; -NODES[3636](BODY_FORCE_X,0) = 0.000000; -NODES[3636](BODY_FORCE_Y,0) = -9.810000; -NODES[3636](BODY_FORCE_Z,0) = 0.000000; -NODES[3637](BODY_FORCE_X,0) = 0.000000; -NODES[3637](BODY_FORCE_Y,0) = -9.810000; -NODES[3637](BODY_FORCE_Z,0) = 0.000000; -NODES[3638](BODY_FORCE_X,0) = 0.000000; -NODES[3638](BODY_FORCE_Y,0) = -9.810000; -NODES[3638](BODY_FORCE_Z,0) = 0.000000; -NODES[3639](BODY_FORCE_X,0) = 0.000000; -NODES[3639](BODY_FORCE_Y,0) = -9.810000; -NODES[3639](BODY_FORCE_Z,0) = 0.000000; -NODES[3640](BODY_FORCE_X,0) = 0.000000; -NODES[3640](BODY_FORCE_Y,0) = -9.810000; -NODES[3640](BODY_FORCE_Z,0) = 0.000000; -NODES[3641](BODY_FORCE_X,0) = 0.000000; -NODES[3641](BODY_FORCE_Y,0) = -9.810000; -NODES[3641](BODY_FORCE_Z,0) = 0.000000; -NODES[3642](BODY_FORCE_X,0) = 0.000000; -NODES[3642](BODY_FORCE_Y,0) = -9.810000; -NODES[3642](BODY_FORCE_Z,0) = 0.000000; -NODES[3643](BODY_FORCE_X,0) = 0.000000; -NODES[3643](BODY_FORCE_Y,0) = -9.810000; -NODES[3643](BODY_FORCE_Z,0) = 0.000000; -NODES[3644](BODY_FORCE_X,0) = 0.000000; -NODES[3644](BODY_FORCE_Y,0) = -9.810000; -NODES[3644](BODY_FORCE_Z,0) = 0.000000; -NODES[3645](BODY_FORCE_X,0) = 0.000000; -NODES[3645](BODY_FORCE_Y,0) = -9.810000; -NODES[3645](BODY_FORCE_Z,0) = 0.000000; -NODES[3646](BODY_FORCE_X,0) = 0.000000; -NODES[3646](BODY_FORCE_Y,0) = -9.810000; -NODES[3646](BODY_FORCE_Z,0) = 0.000000; -NODES[3647](BODY_FORCE_X,0) = 0.000000; -NODES[3647](BODY_FORCE_Y,0) = -9.810000; -NODES[3647](BODY_FORCE_Z,0) = 0.000000; -NODES[3652](BODY_FORCE_X,0) = 0.000000; -NODES[3652](BODY_FORCE_Y,0) = -9.810000; -NODES[3652](BODY_FORCE_Z,0) = 0.000000; -NODES[3655](BODY_FORCE_X,0) = 0.000000; -NODES[3655](BODY_FORCE_Y,0) = -9.810000; -NODES[3655](BODY_FORCE_Z,0) = 0.000000; -NODES[3658](BODY_FORCE_X,0) = 0.000000; -NODES[3658](BODY_FORCE_Y,0) = -9.810000; -NODES[3658](BODY_FORCE_Z,0) = 0.000000; -NODES[3660](BODY_FORCE_X,0) = 0.000000; -NODES[3660](BODY_FORCE_Y,0) = -9.810000; -NODES[3660](BODY_FORCE_Z,0) = 0.000000; -NODES[3662](BODY_FORCE_X,0) = 0.000000; -NODES[3662](BODY_FORCE_Y,0) = -9.810000; -NODES[3662](BODY_FORCE_Z,0) = 0.000000; -NODES[3663](BODY_FORCE_X,0) = 0.000000; -NODES[3663](BODY_FORCE_Y,0) = -9.810000; -NODES[3663](BODY_FORCE_Z,0) = 0.000000; -NODES[3666](BODY_FORCE_X,0) = 0.000000; -NODES[3666](BODY_FORCE_Y,0) = -9.810000; -NODES[3666](BODY_FORCE_Z,0) = 0.000000; -NODES[3672](BODY_FORCE_X,0) = 0.000000; -NODES[3672](BODY_FORCE_Y,0) = -9.810000; -NODES[3672](BODY_FORCE_Z,0) = 0.000000; -NODES[3673](BODY_FORCE_X,0) = 0.000000; -NODES[3673](BODY_FORCE_Y,0) = -9.810000; -NODES[3673](BODY_FORCE_Z,0) = 0.000000; -NODES[3674](BODY_FORCE_X,0) = 0.000000; -NODES[3674](BODY_FORCE_Y,0) = -9.810000; -NODES[3674](BODY_FORCE_Z,0) = 0.000000; -NODES[3675](BODY_FORCE_X,0) = 0.000000; -NODES[3675](BODY_FORCE_Y,0) = -9.810000; -NODES[3675](BODY_FORCE_Z,0) = 0.000000; -NODES[3676](BODY_FORCE_X,0) = 0.000000; -NODES[3676](BODY_FORCE_Y,0) = -9.810000; -NODES[3676](BODY_FORCE_Z,0) = 0.000000; -NODES[3677](BODY_FORCE_X,0) = 0.000000; -NODES[3677](BODY_FORCE_Y,0) = -9.810000; -NODES[3677](BODY_FORCE_Z,0) = 0.000000; -NODES[3678](BODY_FORCE_X,0) = 0.000000; -NODES[3678](BODY_FORCE_Y,0) = -9.810000; -NODES[3678](BODY_FORCE_Z,0) = 0.000000; -NODES[3679](BODY_FORCE_X,0) = 0.000000; -NODES[3679](BODY_FORCE_Y,0) = -9.810000; -NODES[3679](BODY_FORCE_Z,0) = 0.000000; -NODES[3680](BODY_FORCE_X,0) = 0.000000; -NODES[3680](BODY_FORCE_Y,0) = -9.810000; -NODES[3680](BODY_FORCE_Z,0) = 0.000000; -NODES[3681](BODY_FORCE_X,0) = 0.000000; -NODES[3681](BODY_FORCE_Y,0) = -9.810000; -NODES[3681](BODY_FORCE_Z,0) = 0.000000; -NODES[3682](BODY_FORCE_X,0) = 0.000000; -NODES[3682](BODY_FORCE_Y,0) = -9.810000; -NODES[3682](BODY_FORCE_Z,0) = 0.000000; -NODES[3684](BODY_FORCE_X,0) = 0.000000; -NODES[3684](BODY_FORCE_Y,0) = -9.810000; -NODES[3684](BODY_FORCE_Z,0) = 0.000000; -NODES[3685](BODY_FORCE_X,0) = 0.000000; -NODES[3685](BODY_FORCE_Y,0) = -9.810000; -NODES[3685](BODY_FORCE_Z,0) = 0.000000; -NODES[3686](BODY_FORCE_X,0) = 0.000000; -NODES[3686](BODY_FORCE_Y,0) = -9.810000; -NODES[3686](BODY_FORCE_Z,0) = 0.000000; -NODES[3687](BODY_FORCE_X,0) = 0.000000; -NODES[3687](BODY_FORCE_Y,0) = -9.810000; -NODES[3687](BODY_FORCE_Z,0) = 0.000000; -NODES[3688](BODY_FORCE_X,0) = 0.000000; -NODES[3688](BODY_FORCE_Y,0) = -9.810000; -NODES[3688](BODY_FORCE_Z,0) = 0.000000; -NODES[3690](BODY_FORCE_X,0) = 0.000000; -NODES[3690](BODY_FORCE_Y,0) = -9.810000; -NODES[3690](BODY_FORCE_Z,0) = 0.000000; -NODES[3691](BODY_FORCE_X,0) = 0.000000; -NODES[3691](BODY_FORCE_Y,0) = -9.810000; -NODES[3691](BODY_FORCE_Z,0) = 0.000000; -NODES[3693](BODY_FORCE_X,0) = 0.000000; -NODES[3693](BODY_FORCE_Y,0) = -9.810000; -NODES[3693](BODY_FORCE_Z,0) = 0.000000; -NODES[3695](BODY_FORCE_X,0) = 0.000000; -NODES[3695](BODY_FORCE_Y,0) = -9.810000; -NODES[3695](BODY_FORCE_Z,0) = 0.000000; -NODES[3696](BODY_FORCE_X,0) = 0.000000; -NODES[3696](BODY_FORCE_Y,0) = -9.810000; -NODES[3696](BODY_FORCE_Z,0) = 0.000000; -NODES[3697](BODY_FORCE_X,0) = 0.000000; -NODES[3697](BODY_FORCE_Y,0) = -9.810000; -NODES[3697](BODY_FORCE_Z,0) = 0.000000; -NODES[3701](BODY_FORCE_X,0) = 0.000000; -NODES[3701](BODY_FORCE_Y,0) = -9.810000; -NODES[3701](BODY_FORCE_Z,0) = 0.000000; -NODES[3702](BODY_FORCE_X,0) = 0.000000; -NODES[3702](BODY_FORCE_Y,0) = -9.810000; -NODES[3702](BODY_FORCE_Z,0) = 0.000000; -NODES[3703](BODY_FORCE_X,0) = 0.000000; -NODES[3703](BODY_FORCE_Y,0) = -9.810000; -NODES[3703](BODY_FORCE_Z,0) = 0.000000; -NODES[3704](BODY_FORCE_X,0) = 0.000000; -NODES[3704](BODY_FORCE_Y,0) = -9.810000; -NODES[3704](BODY_FORCE_Z,0) = 0.000000; -NODES[3706](BODY_FORCE_X,0) = 0.000000; -NODES[3706](BODY_FORCE_Y,0) = -9.810000; -NODES[3706](BODY_FORCE_Z,0) = 0.000000; -NODES[3707](BODY_FORCE_X,0) = 0.000000; -NODES[3707](BODY_FORCE_Y,0) = -9.810000; -NODES[3707](BODY_FORCE_Z,0) = 0.000000; -NODES[3708](BODY_FORCE_X,0) = 0.000000; -NODES[3708](BODY_FORCE_Y,0) = -9.810000; -NODES[3708](BODY_FORCE_Z,0) = 0.000000; -NODES[3709](BODY_FORCE_X,0) = 0.000000; -NODES[3709](BODY_FORCE_Y,0) = -9.810000; -NODES[3709](BODY_FORCE_Z,0) = 0.000000; -NODES[3710](BODY_FORCE_X,0) = 0.000000; -NODES[3710](BODY_FORCE_Y,0) = -9.810000; -NODES[3710](BODY_FORCE_Z,0) = 0.000000; -NODES[3711](BODY_FORCE_X,0) = 0.000000; -NODES[3711](BODY_FORCE_Y,0) = -9.810000; -NODES[3711](BODY_FORCE_Z,0) = 0.000000; -NODES[3712](BODY_FORCE_X,0) = 0.000000; -NODES[3712](BODY_FORCE_Y,0) = -9.810000; -NODES[3712](BODY_FORCE_Z,0) = 0.000000; -NODES[3713](BODY_FORCE_X,0) = 0.000000; -NODES[3713](BODY_FORCE_Y,0) = -9.810000; -NODES[3713](BODY_FORCE_Z,0) = 0.000000; -NODES[3714](BODY_FORCE_X,0) = 0.000000; -NODES[3714](BODY_FORCE_Y,0) = -9.810000; -NODES[3714](BODY_FORCE_Z,0) = 0.000000; -NODES[3715](BODY_FORCE_X,0) = 0.000000; -NODES[3715](BODY_FORCE_Y,0) = -9.810000; -NODES[3715](BODY_FORCE_Z,0) = 0.000000; -NODES[3717](BODY_FORCE_X,0) = 0.000000; -NODES[3717](BODY_FORCE_Y,0) = -9.810000; -NODES[3717](BODY_FORCE_Z,0) = 0.000000; -NODES[3718](BODY_FORCE_X,0) = 0.000000; -NODES[3718](BODY_FORCE_Y,0) = -9.810000; -NODES[3718](BODY_FORCE_Z,0) = 0.000000; -NODES[3719](BODY_FORCE_X,0) = 0.000000; -NODES[3719](BODY_FORCE_Y,0) = -9.810000; -NODES[3719](BODY_FORCE_Z,0) = 0.000000; -NODES[3720](BODY_FORCE_X,0) = 0.000000; -NODES[3720](BODY_FORCE_Y,0) = -9.810000; -NODES[3720](BODY_FORCE_Z,0) = 0.000000; -NODES[3722](BODY_FORCE_X,0) = 0.000000; -NODES[3722](BODY_FORCE_Y,0) = -9.810000; -NODES[3722](BODY_FORCE_Z,0) = 0.000000; -NODES[3723](BODY_FORCE_X,0) = 0.000000; -NODES[3723](BODY_FORCE_Y,0) = -9.810000; -NODES[3723](BODY_FORCE_Z,0) = 0.000000; -NODES[3725](BODY_FORCE_X,0) = 0.000000; -NODES[3725](BODY_FORCE_Y,0) = -9.810000; -NODES[3725](BODY_FORCE_Z,0) = 0.000000; -NODES[3726](BODY_FORCE_X,0) = 0.000000; -NODES[3726](BODY_FORCE_Y,0) = -9.810000; -NODES[3726](BODY_FORCE_Z,0) = 0.000000; -NODES[3728](BODY_FORCE_X,0) = 0.000000; -NODES[3728](BODY_FORCE_Y,0) = -9.810000; -NODES[3728](BODY_FORCE_Z,0) = 0.000000; -NODES[3730](BODY_FORCE_X,0) = 0.000000; -NODES[3730](BODY_FORCE_Y,0) = -9.810000; -NODES[3730](BODY_FORCE_Z,0) = 0.000000; -NODES[3731](BODY_FORCE_X,0) = 0.000000; -NODES[3731](BODY_FORCE_Y,0) = -9.810000; -NODES[3731](BODY_FORCE_Z,0) = 0.000000; -NODES[3732](BODY_FORCE_X,0) = 0.000000; -NODES[3732](BODY_FORCE_Y,0) = -9.810000; -NODES[3732](BODY_FORCE_Z,0) = 0.000000; -NODES[3733](BODY_FORCE_X,0) = 0.000000; -NODES[3733](BODY_FORCE_Y,0) = -9.810000; -NODES[3733](BODY_FORCE_Z,0) = 0.000000; -NODES[3734](BODY_FORCE_X,0) = 0.000000; -NODES[3734](BODY_FORCE_Y,0) = -9.810000; -NODES[3734](BODY_FORCE_Z,0) = 0.000000; -NODES[3736](BODY_FORCE_X,0) = 0.000000; -NODES[3736](BODY_FORCE_Y,0) = -9.810000; -NODES[3736](BODY_FORCE_Z,0) = 0.000000; -NODES[3737](BODY_FORCE_X,0) = 0.000000; -NODES[3737](BODY_FORCE_Y,0) = -9.810000; -NODES[3737](BODY_FORCE_Z,0) = 0.000000; -NODES[3738](BODY_FORCE_X,0) = 0.000000; -NODES[3738](BODY_FORCE_Y,0) = -9.810000; -NODES[3738](BODY_FORCE_Z,0) = 0.000000; -NODES[3739](BODY_FORCE_X,0) = 0.000000; -NODES[3739](BODY_FORCE_Y,0) = -9.810000; -NODES[3739](BODY_FORCE_Z,0) = 0.000000; -NODES[3740](BODY_FORCE_X,0) = 0.000000; -NODES[3740](BODY_FORCE_Y,0) = -9.810000; -NODES[3740](BODY_FORCE_Z,0) = 0.000000; -NODES[3741](BODY_FORCE_X,0) = 0.000000; -NODES[3741](BODY_FORCE_Y,0) = -9.810000; -NODES[3741](BODY_FORCE_Z,0) = 0.000000; -NODES[3742](BODY_FORCE_X,0) = 0.000000; -NODES[3742](BODY_FORCE_Y,0) = -9.810000; -NODES[3742](BODY_FORCE_Z,0) = 0.000000; -NODES[3743](BODY_FORCE_X,0) = 0.000000; -NODES[3743](BODY_FORCE_Y,0) = -9.810000; -NODES[3743](BODY_FORCE_Z,0) = 0.000000; -NODES[3744](BODY_FORCE_X,0) = 0.000000; -NODES[3744](BODY_FORCE_Y,0) = -9.810000; -NODES[3744](BODY_FORCE_Z,0) = 0.000000; -NODES[3746](BODY_FORCE_X,0) = 0.000000; -NODES[3746](BODY_FORCE_Y,0) = -9.810000; -NODES[3746](BODY_FORCE_Z,0) = 0.000000; -NODES[3747](BODY_FORCE_X,0) = 0.000000; -NODES[3747](BODY_FORCE_Y,0) = -9.810000; -NODES[3747](BODY_FORCE_Z,0) = 0.000000; -NODES[3748](BODY_FORCE_X,0) = 0.000000; -NODES[3748](BODY_FORCE_Y,0) = -9.810000; -NODES[3748](BODY_FORCE_Z,0) = 0.000000; -NODES[3749](BODY_FORCE_X,0) = 0.000000; -NODES[3749](BODY_FORCE_Y,0) = -9.810000; -NODES[3749](BODY_FORCE_Z,0) = 0.000000; -NODES[3751](BODY_FORCE_X,0) = 0.000000; -NODES[3751](BODY_FORCE_Y,0) = -9.810000; -NODES[3751](BODY_FORCE_Z,0) = 0.000000; -NODES[3752](BODY_FORCE_X,0) = 0.000000; -NODES[3752](BODY_FORCE_Y,0) = -9.810000; -NODES[3752](BODY_FORCE_Z,0) = 0.000000; -NODES[3753](BODY_FORCE_X,0) = 0.000000; -NODES[3753](BODY_FORCE_Y,0) = -9.810000; -NODES[3753](BODY_FORCE_Z,0) = 0.000000; -NODES[3756](BODY_FORCE_X,0) = 0.000000; -NODES[3756](BODY_FORCE_Y,0) = -9.810000; -NODES[3756](BODY_FORCE_Z,0) = 0.000000; -NODES[3757](BODY_FORCE_X,0) = 0.000000; -NODES[3757](BODY_FORCE_Y,0) = -9.810000; -NODES[3757](BODY_FORCE_Z,0) = 0.000000; -NODES[3758](BODY_FORCE_X,0) = 0.000000; -NODES[3758](BODY_FORCE_Y,0) = -9.810000; -NODES[3758](BODY_FORCE_Z,0) = 0.000000; -NODES[3759](BODY_FORCE_X,0) = 0.000000; -NODES[3759](BODY_FORCE_Y,0) = -9.810000; -NODES[3759](BODY_FORCE_Z,0) = 0.000000; -NODES[3760](BODY_FORCE_X,0) = 0.000000; -NODES[3760](BODY_FORCE_Y,0) = -9.810000; -NODES[3760](BODY_FORCE_Z,0) = 0.000000; -NODES[3761](BODY_FORCE_X,0) = 0.000000; -NODES[3761](BODY_FORCE_Y,0) = -9.810000; -NODES[3761](BODY_FORCE_Z,0) = 0.000000; -NODES[3762](BODY_FORCE_X,0) = 0.000000; -NODES[3762](BODY_FORCE_Y,0) = -9.810000; -NODES[3762](BODY_FORCE_Z,0) = 0.000000; -NODES[3763](BODY_FORCE_X,0) = 0.000000; -NODES[3763](BODY_FORCE_Y,0) = -9.810000; -NODES[3763](BODY_FORCE_Z,0) = 0.000000; -NODES[3764](BODY_FORCE_X,0) = 0.000000; -NODES[3764](BODY_FORCE_Y,0) = -9.810000; -NODES[3764](BODY_FORCE_Z,0) = 0.000000; -NODES[3766](BODY_FORCE_X,0) = 0.000000; -NODES[3766](BODY_FORCE_Y,0) = -9.810000; -NODES[3766](BODY_FORCE_Z,0) = 0.000000; -NODES[3767](BODY_FORCE_X,0) = 0.000000; -NODES[3767](BODY_FORCE_Y,0) = -9.810000; -NODES[3767](BODY_FORCE_Z,0) = 0.000000; -NODES[3768](BODY_FORCE_X,0) = 0.000000; -NODES[3768](BODY_FORCE_Y,0) = -9.810000; -NODES[3768](BODY_FORCE_Z,0) = 0.000000; -NODES[3769](BODY_FORCE_X,0) = 0.000000; -NODES[3769](BODY_FORCE_Y,0) = -9.810000; -NODES[3769](BODY_FORCE_Z,0) = 0.000000; -NODES[3770](BODY_FORCE_X,0) = 0.000000; -NODES[3770](BODY_FORCE_Y,0) = -9.810000; -NODES[3770](BODY_FORCE_Z,0) = 0.000000; -NODES[3771](BODY_FORCE_X,0) = 0.000000; -NODES[3771](BODY_FORCE_Y,0) = -9.810000; -NODES[3771](BODY_FORCE_Z,0) = 0.000000; -NODES[3772](BODY_FORCE_X,0) = 0.000000; -NODES[3772](BODY_FORCE_Y,0) = -9.810000; -NODES[3772](BODY_FORCE_Z,0) = 0.000000; -NODES[3773](BODY_FORCE_X,0) = 0.000000; -NODES[3773](BODY_FORCE_Y,0) = -9.810000; -NODES[3773](BODY_FORCE_Z,0) = 0.000000; -NODES[3775](BODY_FORCE_X,0) = 0.000000; -NODES[3775](BODY_FORCE_Y,0) = -9.810000; -NODES[3775](BODY_FORCE_Z,0) = 0.000000; -NODES[3776](BODY_FORCE_X,0) = 0.000000; -NODES[3776](BODY_FORCE_Y,0) = -9.810000; -NODES[3776](BODY_FORCE_Z,0) = 0.000000; -NODES[3777](BODY_FORCE_X,0) = 0.000000; -NODES[3777](BODY_FORCE_Y,0) = -9.810000; -NODES[3777](BODY_FORCE_Z,0) = 0.000000; -NODES[3779](BODY_FORCE_X,0) = 0.000000; -NODES[3779](BODY_FORCE_Y,0) = -9.810000; -NODES[3779](BODY_FORCE_Z,0) = 0.000000; -NODES[3780](BODY_FORCE_X,0) = 0.000000; -NODES[3780](BODY_FORCE_Y,0) = -9.810000; -NODES[3780](BODY_FORCE_Z,0) = 0.000000; -NODES[3781](BODY_FORCE_X,0) = 0.000000; -NODES[3781](BODY_FORCE_Y,0) = -9.810000; -NODES[3781](BODY_FORCE_Z,0) = 0.000000; -NODES[3784](BODY_FORCE_X,0) = 0.000000; -NODES[3784](BODY_FORCE_Y,0) = -9.810000; -NODES[3784](BODY_FORCE_Z,0) = 0.000000; -NODES[3785](BODY_FORCE_X,0) = 0.000000; -NODES[3785](BODY_FORCE_Y,0) = -9.810000; -NODES[3785](BODY_FORCE_Z,0) = 0.000000; -NODES[3786](BODY_FORCE_X,0) = 0.000000; -NODES[3786](BODY_FORCE_Y,0) = -9.810000; -NODES[3786](BODY_FORCE_Z,0) = 0.000000; -NODES[3787](BODY_FORCE_X,0) = 0.000000; -NODES[3787](BODY_FORCE_Y,0) = -9.810000; -NODES[3787](BODY_FORCE_Z,0) = 0.000000; -NODES[3788](BODY_FORCE_X,0) = 0.000000; -NODES[3788](BODY_FORCE_Y,0) = -9.810000; -NODES[3788](BODY_FORCE_Z,0) = 0.000000; -NODES[3789](BODY_FORCE_X,0) = 0.000000; -NODES[3789](BODY_FORCE_Y,0) = -9.810000; -NODES[3789](BODY_FORCE_Z,0) = 0.000000; -NODES[3790](BODY_FORCE_X,0) = 0.000000; -NODES[3790](BODY_FORCE_Y,0) = -9.810000; -NODES[3790](BODY_FORCE_Z,0) = 0.000000; -NODES[3791](BODY_FORCE_X,0) = 0.000000; -NODES[3791](BODY_FORCE_Y,0) = -9.810000; -NODES[3791](BODY_FORCE_Z,0) = 0.000000; -NODES[3792](BODY_FORCE_X,0) = 0.000000; -NODES[3792](BODY_FORCE_Y,0) = -9.810000; -NODES[3792](BODY_FORCE_Z,0) = 0.000000; -NODES[3793](BODY_FORCE_X,0) = 0.000000; -NODES[3793](BODY_FORCE_Y,0) = -9.810000; -NODES[3793](BODY_FORCE_Z,0) = 0.000000; -NODES[3794](BODY_FORCE_X,0) = 0.000000; -NODES[3794](BODY_FORCE_Y,0) = -9.810000; -NODES[3794](BODY_FORCE_Z,0) = 0.000000; -NODES[3795](BODY_FORCE_X,0) = 0.000000; -NODES[3795](BODY_FORCE_Y,0) = -9.810000; -NODES[3795](BODY_FORCE_Z,0) = 0.000000; -NODES[3796](BODY_FORCE_X,0) = 0.000000; -NODES[3796](BODY_FORCE_Y,0) = -9.810000; -NODES[3796](BODY_FORCE_Z,0) = 0.000000; -NODES[3797](BODY_FORCE_X,0) = 0.000000; -NODES[3797](BODY_FORCE_Y,0) = -9.810000; -NODES[3797](BODY_FORCE_Z,0) = 0.000000; -NODES[3798](BODY_FORCE_X,0) = 0.000000; -NODES[3798](BODY_FORCE_Y,0) = -9.810000; -NODES[3798](BODY_FORCE_Z,0) = 0.000000; -NODES[3800](BODY_FORCE_X,0) = 0.000000; -NODES[3800](BODY_FORCE_Y,0) = -9.810000; -NODES[3800](BODY_FORCE_Z,0) = 0.000000; -NODES[3801](BODY_FORCE_X,0) = 0.000000; -NODES[3801](BODY_FORCE_Y,0) = -9.810000; -NODES[3801](BODY_FORCE_Z,0) = 0.000000; -NODES[3802](BODY_FORCE_X,0) = 0.000000; -NODES[3802](BODY_FORCE_Y,0) = -9.810000; -NODES[3802](BODY_FORCE_Z,0) = 0.000000; -NODES[3803](BODY_FORCE_X,0) = 0.000000; -NODES[3803](BODY_FORCE_Y,0) = -9.810000; -NODES[3803](BODY_FORCE_Z,0) = 0.000000; -NODES[3804](BODY_FORCE_X,0) = 0.000000; -NODES[3804](BODY_FORCE_Y,0) = -9.810000; -NODES[3804](BODY_FORCE_Z,0) = 0.000000; -NODES[3806](BODY_FORCE_X,0) = 0.000000; -NODES[3806](BODY_FORCE_Y,0) = -9.810000; -NODES[3806](BODY_FORCE_Z,0) = 0.000000; -NODES[3808](BODY_FORCE_X,0) = 0.000000; -NODES[3808](BODY_FORCE_Y,0) = -9.810000; -NODES[3808](BODY_FORCE_Z,0) = 0.000000; -NODES[3809](BODY_FORCE_X,0) = 0.000000; -NODES[3809](BODY_FORCE_Y,0) = -9.810000; -NODES[3809](BODY_FORCE_Z,0) = 0.000000; -NODES[3811](BODY_FORCE_X,0) = 0.000000; -NODES[3811](BODY_FORCE_Y,0) = -9.810000; -NODES[3811](BODY_FORCE_Z,0) = 0.000000; -NODES[3812](BODY_FORCE_X,0) = 0.000000; -NODES[3812](BODY_FORCE_Y,0) = -9.810000; -NODES[3812](BODY_FORCE_Z,0) = 0.000000; -NODES[3813](BODY_FORCE_X,0) = 0.000000; -NODES[3813](BODY_FORCE_Y,0) = -9.810000; -NODES[3813](BODY_FORCE_Z,0) = 0.000000; -NODES[3814](BODY_FORCE_X,0) = 0.000000; -NODES[3814](BODY_FORCE_Y,0) = -9.810000; -NODES[3814](BODY_FORCE_Z,0) = 0.000000; -NODES[3815](BODY_FORCE_X,0) = 0.000000; -NODES[3815](BODY_FORCE_Y,0) = -9.810000; -NODES[3815](BODY_FORCE_Z,0) = 0.000000; -NODES[3816](BODY_FORCE_X,0) = 0.000000; -NODES[3816](BODY_FORCE_Y,0) = -9.810000; -NODES[3816](BODY_FORCE_Z,0) = 0.000000; -NODES[3817](BODY_FORCE_X,0) = 0.000000; -NODES[3817](BODY_FORCE_Y,0) = -9.810000; -NODES[3817](BODY_FORCE_Z,0) = 0.000000; -NODES[3818](BODY_FORCE_X,0) = 0.000000; -NODES[3818](BODY_FORCE_Y,0) = -9.810000; -NODES[3818](BODY_FORCE_Z,0) = 0.000000; -NODES[3819](BODY_FORCE_X,0) = 0.000000; -NODES[3819](BODY_FORCE_Y,0) = -9.810000; -NODES[3819](BODY_FORCE_Z,0) = 0.000000; -NODES[3820](BODY_FORCE_X,0) = 0.000000; -NODES[3820](BODY_FORCE_Y,0) = -9.810000; -NODES[3820](BODY_FORCE_Z,0) = 0.000000; -NODES[3821](BODY_FORCE_X,0) = 0.000000; -NODES[3821](BODY_FORCE_Y,0) = -9.810000; -NODES[3821](BODY_FORCE_Z,0) = 0.000000; -NODES[3822](BODY_FORCE_X,0) = 0.000000; -NODES[3822](BODY_FORCE_Y,0) = -9.810000; -NODES[3822](BODY_FORCE_Z,0) = 0.000000; -NODES[3823](BODY_FORCE_X,0) = 0.000000; -NODES[3823](BODY_FORCE_Y,0) = -9.810000; -NODES[3823](BODY_FORCE_Z,0) = 0.000000; -NODES[3825](BODY_FORCE_X,0) = 0.000000; -NODES[3825](BODY_FORCE_Y,0) = -9.810000; -NODES[3825](BODY_FORCE_Z,0) = 0.000000; -NODES[3826](BODY_FORCE_X,0) = 0.000000; -NODES[3826](BODY_FORCE_Y,0) = -9.810000; -NODES[3826](BODY_FORCE_Z,0) = 0.000000; -NODES[3827](BODY_FORCE_X,0) = 0.000000; -NODES[3827](BODY_FORCE_Y,0) = -9.810000; -NODES[3827](BODY_FORCE_Z,0) = 0.000000; -NODES[3828](BODY_FORCE_X,0) = 0.000000; -NODES[3828](BODY_FORCE_Y,0) = -9.810000; -NODES[3828](BODY_FORCE_Z,0) = 0.000000; -NODES[3829](BODY_FORCE_X,0) = 0.000000; -NODES[3829](BODY_FORCE_Y,0) = -9.810000; -NODES[3829](BODY_FORCE_Z,0) = 0.000000; -NODES[3830](BODY_FORCE_X,0) = 0.000000; -NODES[3830](BODY_FORCE_Y,0) = -9.810000; -NODES[3830](BODY_FORCE_Z,0) = 0.000000; -NODES[3832](BODY_FORCE_X,0) = 0.000000; -NODES[3832](BODY_FORCE_Y,0) = -9.810000; -NODES[3832](BODY_FORCE_Z,0) = 0.000000; -NODES[3834](BODY_FORCE_X,0) = 0.000000; -NODES[3834](BODY_FORCE_Y,0) = -9.810000; -NODES[3834](BODY_FORCE_Z,0) = 0.000000; -NODES[3835](BODY_FORCE_X,0) = 0.000000; -NODES[3835](BODY_FORCE_Y,0) = -9.810000; -NODES[3835](BODY_FORCE_Z,0) = 0.000000; -NODES[3836](BODY_FORCE_X,0) = 0.000000; -NODES[3836](BODY_FORCE_Y,0) = -9.810000; -NODES[3836](BODY_FORCE_Z,0) = 0.000000; -NODES[3837](BODY_FORCE_X,0) = 0.000000; -NODES[3837](BODY_FORCE_Y,0) = -9.810000; -NODES[3837](BODY_FORCE_Z,0) = 0.000000; -NODES[3838](BODY_FORCE_X,0) = 0.000000; -NODES[3838](BODY_FORCE_Y,0) = -9.810000; -NODES[3838](BODY_FORCE_Z,0) = 0.000000; -NODES[3839](BODY_FORCE_X,0) = 0.000000; -NODES[3839](BODY_FORCE_Y,0) = -9.810000; -NODES[3839](BODY_FORCE_Z,0) = 0.000000; -NODES[3840](BODY_FORCE_X,0) = 0.000000; -NODES[3840](BODY_FORCE_Y,0) = -9.810000; -NODES[3840](BODY_FORCE_Z,0) = 0.000000; -NODES[3841](BODY_FORCE_X,0) = 0.000000; -NODES[3841](BODY_FORCE_Y,0) = -9.810000; -NODES[3841](BODY_FORCE_Z,0) = 0.000000; -NODES[3842](BODY_FORCE_X,0) = 0.000000; -NODES[3842](BODY_FORCE_Y,0) = -9.810000; -NODES[3842](BODY_FORCE_Z,0) = 0.000000; -NODES[3844](BODY_FORCE_X,0) = 0.000000; -NODES[3844](BODY_FORCE_Y,0) = -9.810000; -NODES[3844](BODY_FORCE_Z,0) = 0.000000; -NODES[3845](BODY_FORCE_X,0) = 0.000000; -NODES[3845](BODY_FORCE_Y,0) = -9.810000; -NODES[3845](BODY_FORCE_Z,0) = 0.000000; -NODES[3846](BODY_FORCE_X,0) = 0.000000; -NODES[3846](BODY_FORCE_Y,0) = -9.810000; -NODES[3846](BODY_FORCE_Z,0) = 0.000000; -NODES[3847](BODY_FORCE_X,0) = 0.000000; -NODES[3847](BODY_FORCE_Y,0) = -9.810000; -NODES[3847](BODY_FORCE_Z,0) = 0.000000; -NODES[3848](BODY_FORCE_X,0) = 0.000000; -NODES[3848](BODY_FORCE_Y,0) = -9.810000; -NODES[3848](BODY_FORCE_Z,0) = 0.000000; -NODES[3849](BODY_FORCE_X,0) = 0.000000; -NODES[3849](BODY_FORCE_Y,0) = -9.810000; -NODES[3849](BODY_FORCE_Z,0) = 0.000000; -NODES[3850](BODY_FORCE_X,0) = 0.000000; -NODES[3850](BODY_FORCE_Y,0) = -9.810000; -NODES[3850](BODY_FORCE_Z,0) = 0.000000; -NODES[3851](BODY_FORCE_X,0) = 0.000000; -NODES[3851](BODY_FORCE_Y,0) = -9.810000; -NODES[3851](BODY_FORCE_Z,0) = 0.000000; -NODES[3853](BODY_FORCE_X,0) = 0.000000; -NODES[3853](BODY_FORCE_Y,0) = -9.810000; -NODES[3853](BODY_FORCE_Z,0) = 0.000000; -NODES[3854](BODY_FORCE_X,0) = 0.000000; -NODES[3854](BODY_FORCE_Y,0) = -9.810000; -NODES[3854](BODY_FORCE_Z,0) = 0.000000; -NODES[3855](BODY_FORCE_X,0) = 0.000000; -NODES[3855](BODY_FORCE_Y,0) = -9.810000; -NODES[3855](BODY_FORCE_Z,0) = 0.000000; -NODES[3856](BODY_FORCE_X,0) = 0.000000; -NODES[3856](BODY_FORCE_Y,0) = -9.810000; -NODES[3856](BODY_FORCE_Z,0) = 0.000000; -NODES[3858](BODY_FORCE_X,0) = 0.000000; -NODES[3858](BODY_FORCE_Y,0) = -9.810000; -NODES[3858](BODY_FORCE_Z,0) = 0.000000; -NODES[3859](BODY_FORCE_X,0) = 0.000000; -NODES[3859](BODY_FORCE_Y,0) = -9.810000; -NODES[3859](BODY_FORCE_Z,0) = 0.000000; -NODES[3860](BODY_FORCE_X,0) = 0.000000; -NODES[3860](BODY_FORCE_Y,0) = -9.810000; -NODES[3860](BODY_FORCE_Z,0) = 0.000000; -NODES[3861](BODY_FORCE_X,0) = 0.000000; -NODES[3861](BODY_FORCE_Y,0) = -9.810000; -NODES[3861](BODY_FORCE_Z,0) = 0.000000; -NODES[3863](BODY_FORCE_X,0) = 0.000000; -NODES[3863](BODY_FORCE_Y,0) = -9.810000; -NODES[3863](BODY_FORCE_Z,0) = 0.000000; -NODES[3864](BODY_FORCE_X,0) = 0.000000; -NODES[3864](BODY_FORCE_Y,0) = -9.810000; -NODES[3864](BODY_FORCE_Z,0) = 0.000000; -NODES[3865](BODY_FORCE_X,0) = 0.000000; -NODES[3865](BODY_FORCE_Y,0) = -9.810000; -NODES[3865](BODY_FORCE_Z,0) = 0.000000; -NODES[3866](BODY_FORCE_X,0) = 0.000000; -NODES[3866](BODY_FORCE_Y,0) = -9.810000; -NODES[3866](BODY_FORCE_Z,0) = 0.000000; -NODES[3867](BODY_FORCE_X,0) = 0.000000; -NODES[3867](BODY_FORCE_Y,0) = -9.810000; -NODES[3867](BODY_FORCE_Z,0) = 0.000000; -NODES[3868](BODY_FORCE_X,0) = 0.000000; -NODES[3868](BODY_FORCE_Y,0) = -9.810000; -NODES[3868](BODY_FORCE_Z,0) = 0.000000; -NODES[3869](BODY_FORCE_X,0) = 0.000000; -NODES[3869](BODY_FORCE_Y,0) = -9.810000; -NODES[3869](BODY_FORCE_Z,0) = 0.000000; -NODES[3870](BODY_FORCE_X,0) = 0.000000; -NODES[3870](BODY_FORCE_Y,0) = -9.810000; -NODES[3870](BODY_FORCE_Z,0) = 0.000000; -NODES[3871](BODY_FORCE_X,0) = 0.000000; -NODES[3871](BODY_FORCE_Y,0) = -9.810000; -NODES[3871](BODY_FORCE_Z,0) = 0.000000; -NODES[3872](BODY_FORCE_X,0) = 0.000000; -NODES[3872](BODY_FORCE_Y,0) = -9.810000; -NODES[3872](BODY_FORCE_Z,0) = 0.000000; -NODES[3873](BODY_FORCE_X,0) = 0.000000; -NODES[3873](BODY_FORCE_Y,0) = -9.810000; -NODES[3873](BODY_FORCE_Z,0) = 0.000000; -NODES[3874](BODY_FORCE_X,0) = 0.000000; -NODES[3874](BODY_FORCE_Y,0) = -9.810000; -NODES[3874](BODY_FORCE_Z,0) = 0.000000; -NODES[3876](BODY_FORCE_X,0) = 0.000000; -NODES[3876](BODY_FORCE_Y,0) = -9.810000; -NODES[3876](BODY_FORCE_Z,0) = 0.000000; -NODES[3877](BODY_FORCE_X,0) = 0.000000; -NODES[3877](BODY_FORCE_Y,0) = -9.810000; -NODES[3877](BODY_FORCE_Z,0) = 0.000000; -NODES[3878](BODY_FORCE_X,0) = 0.000000; -NODES[3878](BODY_FORCE_Y,0) = -9.810000; -NODES[3878](BODY_FORCE_Z,0) = 0.000000; -NODES[3880](BODY_FORCE_X,0) = 0.000000; -NODES[3880](BODY_FORCE_Y,0) = -9.810000; -NODES[3880](BODY_FORCE_Z,0) = 0.000000; -NODES[3881](BODY_FORCE_X,0) = 0.000000; -NODES[3881](BODY_FORCE_Y,0) = -9.810000; -NODES[3881](BODY_FORCE_Z,0) = 0.000000; -NODES[3882](BODY_FORCE_X,0) = 0.000000; -NODES[3882](BODY_FORCE_Y,0) = -9.810000; -NODES[3882](BODY_FORCE_Z,0) = 0.000000; -NODES[3883](BODY_FORCE_X,0) = 0.000000; -NODES[3883](BODY_FORCE_Y,0) = -9.810000; -NODES[3883](BODY_FORCE_Z,0) = 0.000000; -NODES[3884](BODY_FORCE_X,0) = 0.000000; -NODES[3884](BODY_FORCE_Y,0) = -9.810000; -NODES[3884](BODY_FORCE_Z,0) = 0.000000; -NODES[3885](BODY_FORCE_X,0) = 0.000000; -NODES[3885](BODY_FORCE_Y,0) = -9.810000; -NODES[3885](BODY_FORCE_Z,0) = 0.000000; -NODES[3886](BODY_FORCE_X,0) = 0.000000; -NODES[3886](BODY_FORCE_Y,0) = -9.810000; -NODES[3886](BODY_FORCE_Z,0) = 0.000000; -NODES[3887](BODY_FORCE_X,0) = 0.000000; -NODES[3887](BODY_FORCE_Y,0) = -9.810000; -NODES[3887](BODY_FORCE_Z,0) = 0.000000; -NODES[3889](BODY_FORCE_X,0) = 0.000000; -NODES[3889](BODY_FORCE_Y,0) = -9.810000; -NODES[3889](BODY_FORCE_Z,0) = 0.000000; -NODES[3890](BODY_FORCE_X,0) = 0.000000; -NODES[3890](BODY_FORCE_Y,0) = -9.810000; -NODES[3890](BODY_FORCE_Z,0) = 0.000000; -NODES[3891](BODY_FORCE_X,0) = 0.000000; -NODES[3891](BODY_FORCE_Y,0) = -9.810000; -NODES[3891](BODY_FORCE_Z,0) = 0.000000; -NODES[3892](BODY_FORCE_X,0) = 0.000000; -NODES[3892](BODY_FORCE_Y,0) = -9.810000; -NODES[3892](BODY_FORCE_Z,0) = 0.000000; -NODES[3893](BODY_FORCE_X,0) = 0.000000; -NODES[3893](BODY_FORCE_Y,0) = -9.810000; -NODES[3893](BODY_FORCE_Z,0) = 0.000000; -NODES[3894](BODY_FORCE_X,0) = 0.000000; -NODES[3894](BODY_FORCE_Y,0) = -9.810000; -NODES[3894](BODY_FORCE_Z,0) = 0.000000; -NODES[3895](BODY_FORCE_X,0) = 0.000000; -NODES[3895](BODY_FORCE_Y,0) = -9.810000; -NODES[3895](BODY_FORCE_Z,0) = 0.000000; -NODES[3896](BODY_FORCE_X,0) = 0.000000; -NODES[3896](BODY_FORCE_Y,0) = -9.810000; -NODES[3896](BODY_FORCE_Z,0) = 0.000000; -NODES[3897](BODY_FORCE_X,0) = 0.000000; -NODES[3897](BODY_FORCE_Y,0) = -9.810000; -NODES[3897](BODY_FORCE_Z,0) = 0.000000; -NODES[3898](BODY_FORCE_X,0) = 0.000000; -NODES[3898](BODY_FORCE_Y,0) = -9.810000; -NODES[3898](BODY_FORCE_Z,0) = 0.000000; -NODES[3899](BODY_FORCE_X,0) = 0.000000; -NODES[3899](BODY_FORCE_Y,0) = -9.810000; -NODES[3899](BODY_FORCE_Z,0) = 0.000000; -NODES[3901](BODY_FORCE_X,0) = 0.000000; -NODES[3901](BODY_FORCE_Y,0) = -9.810000; -NODES[3901](BODY_FORCE_Z,0) = 0.000000; -NODES[3902](BODY_FORCE_X,0) = 0.000000; -NODES[3902](BODY_FORCE_Y,0) = -9.810000; -NODES[3902](BODY_FORCE_Z,0) = 0.000000; -NODES[3903](BODY_FORCE_X,0) = 0.000000; -NODES[3903](BODY_FORCE_Y,0) = -9.810000; -NODES[3903](BODY_FORCE_Z,0) = 0.000000; -NODES[3904](BODY_FORCE_X,0) = 0.000000; -NODES[3904](BODY_FORCE_Y,0) = -9.810000; -NODES[3904](BODY_FORCE_Z,0) = 0.000000; -NODES[3906](BODY_FORCE_X,0) = 0.000000; -NODES[3906](BODY_FORCE_Y,0) = -9.810000; -NODES[3906](BODY_FORCE_Z,0) = 0.000000; -NODES[3907](BODY_FORCE_X,0) = 0.000000; -NODES[3907](BODY_FORCE_Y,0) = -9.810000; -NODES[3907](BODY_FORCE_Z,0) = 0.000000; -NODES[3908](BODY_FORCE_X,0) = 0.000000; -NODES[3908](BODY_FORCE_Y,0) = -9.810000; -NODES[3908](BODY_FORCE_Z,0) = 0.000000; -NODES[3909](BODY_FORCE_X,0) = 0.000000; -NODES[3909](BODY_FORCE_Y,0) = -9.810000; -NODES[3909](BODY_FORCE_Z,0) = 0.000000; -NODES[3910](BODY_FORCE_X,0) = 0.000000; -NODES[3910](BODY_FORCE_Y,0) = -9.810000; -NODES[3910](BODY_FORCE_Z,0) = 0.000000; -NODES[3911](BODY_FORCE_X,0) = 0.000000; -NODES[3911](BODY_FORCE_Y,0) = -9.810000; -NODES[3911](BODY_FORCE_Z,0) = 0.000000; -NODES[3913](BODY_FORCE_X,0) = 0.000000; -NODES[3913](BODY_FORCE_Y,0) = -9.810000; -NODES[3913](BODY_FORCE_Z,0) = 0.000000; -NODES[3914](BODY_FORCE_X,0) = 0.000000; -NODES[3914](BODY_FORCE_Y,0) = -9.810000; -NODES[3914](BODY_FORCE_Z,0) = 0.000000; -NODES[3915](BODY_FORCE_X,0) = 0.000000; -NODES[3915](BODY_FORCE_Y,0) = -9.810000; -NODES[3915](BODY_FORCE_Z,0) = 0.000000; -NODES[3916](BODY_FORCE_X,0) = 0.000000; -NODES[3916](BODY_FORCE_Y,0) = -9.810000; -NODES[3916](BODY_FORCE_Z,0) = 0.000000; -NODES[3917](BODY_FORCE_X,0) = 0.000000; -NODES[3917](BODY_FORCE_Y,0) = -9.810000; -NODES[3917](BODY_FORCE_Z,0) = 0.000000; -NODES[3918](BODY_FORCE_X,0) = 0.000000; -NODES[3918](BODY_FORCE_Y,0) = -9.810000; -NODES[3918](BODY_FORCE_Z,0) = 0.000000; -NODES[3919](BODY_FORCE_X,0) = 0.000000; -NODES[3919](BODY_FORCE_Y,0) = -9.810000; -NODES[3919](BODY_FORCE_Z,0) = 0.000000; -NODES[3920](BODY_FORCE_X,0) = 0.000000; -NODES[3920](BODY_FORCE_Y,0) = -9.810000; -NODES[3920](BODY_FORCE_Z,0) = 0.000000; -NODES[3921](BODY_FORCE_X,0) = 0.000000; -NODES[3921](BODY_FORCE_Y,0) = -9.810000; -NODES[3921](BODY_FORCE_Z,0) = 0.000000; -NODES[3922](BODY_FORCE_X,0) = 0.000000; -NODES[3922](BODY_FORCE_Y,0) = -9.810000; -NODES[3922](BODY_FORCE_Z,0) = 0.000000; -NODES[3924](BODY_FORCE_X,0) = 0.000000; -NODES[3924](BODY_FORCE_Y,0) = -9.810000; -NODES[3924](BODY_FORCE_Z,0) = 0.000000; -NODES[3925](BODY_FORCE_X,0) = 0.000000; -NODES[3925](BODY_FORCE_Y,0) = -9.810000; -NODES[3925](BODY_FORCE_Z,0) = 0.000000; -NODES[3926](BODY_FORCE_X,0) = 0.000000; -NODES[3926](BODY_FORCE_Y,0) = -9.810000; -NODES[3926](BODY_FORCE_Z,0) = 0.000000; -NODES[3927](BODY_FORCE_X,0) = 0.000000; -NODES[3927](BODY_FORCE_Y,0) = -9.810000; -NODES[3927](BODY_FORCE_Z,0) = 0.000000; -NODES[3928](BODY_FORCE_X,0) = 0.000000; -NODES[3928](BODY_FORCE_Y,0) = -9.810000; -NODES[3928](BODY_FORCE_Z,0) = 0.000000; -NODES[3929](BODY_FORCE_X,0) = 0.000000; -NODES[3929](BODY_FORCE_Y,0) = -9.810000; -NODES[3929](BODY_FORCE_Z,0) = 0.000000; -NODES[3930](BODY_FORCE_X,0) = 0.000000; -NODES[3930](BODY_FORCE_Y,0) = -9.810000; -NODES[3930](BODY_FORCE_Z,0) = 0.000000; -NODES[3932](BODY_FORCE_X,0) = 0.000000; -NODES[3932](BODY_FORCE_Y,0) = -9.810000; -NODES[3932](BODY_FORCE_Z,0) = 0.000000; -NODES[3933](BODY_FORCE_X,0) = 0.000000; -NODES[3933](BODY_FORCE_Y,0) = -9.810000; -NODES[3933](BODY_FORCE_Z,0) = 0.000000; -NODES[3934](BODY_FORCE_X,0) = 0.000000; -NODES[3934](BODY_FORCE_Y,0) = -9.810000; -NODES[3934](BODY_FORCE_Z,0) = 0.000000; -NODES[3935](BODY_FORCE_X,0) = 0.000000; -NODES[3935](BODY_FORCE_Y,0) = -9.810000; -NODES[3935](BODY_FORCE_Z,0) = 0.000000; -NODES[3936](BODY_FORCE_X,0) = 0.000000; -NODES[3936](BODY_FORCE_Y,0) = -9.810000; -NODES[3936](BODY_FORCE_Z,0) = 0.000000; -NODES[3937](BODY_FORCE_X,0) = 0.000000; -NODES[3937](BODY_FORCE_Y,0) = -9.810000; -NODES[3937](BODY_FORCE_Z,0) = 0.000000; -NODES[3938](BODY_FORCE_X,0) = 0.000000; -NODES[3938](BODY_FORCE_Y,0) = -9.810000; -NODES[3938](BODY_FORCE_Z,0) = 0.000000; -NODES[3940](BODY_FORCE_X,0) = 0.000000; -NODES[3940](BODY_FORCE_Y,0) = -9.810000; -NODES[3940](BODY_FORCE_Z,0) = 0.000000; -NODES[3941](BODY_FORCE_X,0) = 0.000000; -NODES[3941](BODY_FORCE_Y,0) = -9.810000; -NODES[3941](BODY_FORCE_Z,0) = 0.000000; -NODES[3942](BODY_FORCE_X,0) = 0.000000; -NODES[3942](BODY_FORCE_Y,0) = -9.810000; -NODES[3942](BODY_FORCE_Z,0) = 0.000000; -NODES[3943](BODY_FORCE_X,0) = 0.000000; -NODES[3943](BODY_FORCE_Y,0) = -9.810000; -NODES[3943](BODY_FORCE_Z,0) = 0.000000; -NODES[3944](BODY_FORCE_X,0) = 0.000000; -NODES[3944](BODY_FORCE_Y,0) = -9.810000; -NODES[3944](BODY_FORCE_Z,0) = 0.000000; -NODES[3945](BODY_FORCE_X,0) = 0.000000; -NODES[3945](BODY_FORCE_Y,0) = -9.810000; -NODES[3945](BODY_FORCE_Z,0) = 0.000000; -NODES[3946](BODY_FORCE_X,0) = 0.000000; -NODES[3946](BODY_FORCE_Y,0) = -9.810000; -NODES[3946](BODY_FORCE_Z,0) = 0.000000; -NODES[3947](BODY_FORCE_X,0) = 0.000000; -NODES[3947](BODY_FORCE_Y,0) = -9.810000; -NODES[3947](BODY_FORCE_Z,0) = 0.000000; -NODES[3948](BODY_FORCE_X,0) = 0.000000; -NODES[3948](BODY_FORCE_Y,0) = -9.810000; -NODES[3948](BODY_FORCE_Z,0) = 0.000000; -NODES[3949](BODY_FORCE_X,0) = 0.000000; -NODES[3949](BODY_FORCE_Y,0) = -9.810000; -NODES[3949](BODY_FORCE_Z,0) = 0.000000; -NODES[3951](BODY_FORCE_X,0) = 0.000000; -NODES[3951](BODY_FORCE_Y,0) = -9.810000; -NODES[3951](BODY_FORCE_Z,0) = 0.000000; -NODES[3952](BODY_FORCE_X,0) = 0.000000; -NODES[3952](BODY_FORCE_Y,0) = -9.810000; -NODES[3952](BODY_FORCE_Z,0) = 0.000000; -NODES[3953](BODY_FORCE_X,0) = 0.000000; -NODES[3953](BODY_FORCE_Y,0) = -9.810000; -NODES[3953](BODY_FORCE_Z,0) = 0.000000; -NODES[3954](BODY_FORCE_X,0) = 0.000000; -NODES[3954](BODY_FORCE_Y,0) = -9.810000; -NODES[3954](BODY_FORCE_Z,0) = 0.000000; -NODES[3955](BODY_FORCE_X,0) = 0.000000; -NODES[3955](BODY_FORCE_Y,0) = -9.810000; -NODES[3955](BODY_FORCE_Z,0) = 0.000000; -NODES[3956](BODY_FORCE_X,0) = 0.000000; -NODES[3956](BODY_FORCE_Y,0) = -9.810000; -NODES[3956](BODY_FORCE_Z,0) = 0.000000; -NODES[3958](BODY_FORCE_X,0) = 0.000000; -NODES[3958](BODY_FORCE_Y,0) = -9.810000; -NODES[3958](BODY_FORCE_Z,0) = 0.000000; -NODES[3959](BODY_FORCE_X,0) = 0.000000; -NODES[3959](BODY_FORCE_Y,0) = -9.810000; -NODES[3959](BODY_FORCE_Z,0) = 0.000000; -NODES[3960](BODY_FORCE_X,0) = 0.000000; -NODES[3960](BODY_FORCE_Y,0) = -9.810000; -NODES[3960](BODY_FORCE_Z,0) = 0.000000; -NODES[3961](BODY_FORCE_X,0) = 0.000000; -NODES[3961](BODY_FORCE_Y,0) = -9.810000; -NODES[3961](BODY_FORCE_Z,0) = 0.000000; -NODES[3962](BODY_FORCE_X,0) = 0.000000; -NODES[3962](BODY_FORCE_Y,0) = -9.810000; -NODES[3962](BODY_FORCE_Z,0) = 0.000000; -NODES[3963](BODY_FORCE_X,0) = 0.000000; -NODES[3963](BODY_FORCE_Y,0) = -9.810000; -NODES[3963](BODY_FORCE_Z,0) = 0.000000; -NODES[3964](BODY_FORCE_X,0) = 0.000000; -NODES[3964](BODY_FORCE_Y,0) = -9.810000; -NODES[3964](BODY_FORCE_Z,0) = 0.000000; -NODES[3966](BODY_FORCE_X,0) = 0.000000; -NODES[3966](BODY_FORCE_Y,0) = -9.810000; -NODES[3966](BODY_FORCE_Z,0) = 0.000000; -NODES[3967](BODY_FORCE_X,0) = 0.000000; -NODES[3967](BODY_FORCE_Y,0) = -9.810000; -NODES[3967](BODY_FORCE_Z,0) = 0.000000; -NODES[3968](BODY_FORCE_X,0) = 0.000000; -NODES[3968](BODY_FORCE_Y,0) = -9.810000; -NODES[3968](BODY_FORCE_Z,0) = 0.000000; -NODES[3969](BODY_FORCE_X,0) = 0.000000; -NODES[3969](BODY_FORCE_Y,0) = -9.810000; -NODES[3969](BODY_FORCE_Z,0) = 0.000000; -NODES[3970](BODY_FORCE_X,0) = 0.000000; -NODES[3970](BODY_FORCE_Y,0) = -9.810000; -NODES[3970](BODY_FORCE_Z,0) = 0.000000; -NODES[3971](BODY_FORCE_X,0) = 0.000000; -NODES[3971](BODY_FORCE_Y,0) = -9.810000; -NODES[3971](BODY_FORCE_Z,0) = 0.000000; -NODES[3972](BODY_FORCE_X,0) = 0.000000; -NODES[3972](BODY_FORCE_Y,0) = -9.810000; -NODES[3972](BODY_FORCE_Z,0) = 0.000000; -NODES[3973](BODY_FORCE_X,0) = 0.000000; -NODES[3973](BODY_FORCE_Y,0) = -9.810000; -NODES[3973](BODY_FORCE_Z,0) = 0.000000; -NODES[3974](BODY_FORCE_X,0) = 0.000000; -NODES[3974](BODY_FORCE_Y,0) = -9.810000; -NODES[3974](BODY_FORCE_Z,0) = 0.000000; -NODES[3975](BODY_FORCE_X,0) = 0.000000; -NODES[3975](BODY_FORCE_Y,0) = -9.810000; -NODES[3975](BODY_FORCE_Z,0) = 0.000000; -NODES[3977](BODY_FORCE_X,0) = 0.000000; -NODES[3977](BODY_FORCE_Y,0) = -9.810000; -NODES[3977](BODY_FORCE_Z,0) = 0.000000; -NODES[3978](BODY_FORCE_X,0) = 0.000000; -NODES[3978](BODY_FORCE_Y,0) = -9.810000; -NODES[3978](BODY_FORCE_Z,0) = 0.000000; -NODES[3979](BODY_FORCE_X,0) = 0.000000; -NODES[3979](BODY_FORCE_Y,0) = -9.810000; -NODES[3979](BODY_FORCE_Z,0) = 0.000000; -NODES[3980](BODY_FORCE_X,0) = 0.000000; -NODES[3980](BODY_FORCE_Y,0) = -9.810000; -NODES[3980](BODY_FORCE_Z,0) = 0.000000; -NODES[3981](BODY_FORCE_X,0) = 0.000000; -NODES[3981](BODY_FORCE_Y,0) = -9.810000; -NODES[3981](BODY_FORCE_Z,0) = 0.000000; -NODES[3982](BODY_FORCE_X,0) = 0.000000; -NODES[3982](BODY_FORCE_Y,0) = -9.810000; -NODES[3982](BODY_FORCE_Z,0) = 0.000000; -NODES[3983](BODY_FORCE_X,0) = 0.000000; -NODES[3983](BODY_FORCE_Y,0) = -9.810000; -NODES[3983](BODY_FORCE_Z,0) = 0.000000; -NODES[3984](BODY_FORCE_X,0) = 0.000000; -NODES[3984](BODY_FORCE_Y,0) = -9.810000; -NODES[3984](BODY_FORCE_Z,0) = 0.000000; -NODES[3985](BODY_FORCE_X,0) = 0.000000; -NODES[3985](BODY_FORCE_Y,0) = -9.810000; -NODES[3985](BODY_FORCE_Z,0) = 0.000000; -NODES[3987](BODY_FORCE_X,0) = 0.000000; -NODES[3987](BODY_FORCE_Y,0) = -9.810000; -NODES[3987](BODY_FORCE_Z,0) = 0.000000; -NODES[3988](BODY_FORCE_X,0) = 0.000000; -NODES[3988](BODY_FORCE_Y,0) = -9.810000; -NODES[3988](BODY_FORCE_Z,0) = 0.000000; -NODES[3989](BODY_FORCE_X,0) = 0.000000; -NODES[3989](BODY_FORCE_Y,0) = -9.810000; -NODES[3989](BODY_FORCE_Z,0) = 0.000000; -NODES[3990](BODY_FORCE_X,0) = 0.000000; -NODES[3990](BODY_FORCE_Y,0) = -9.810000; -NODES[3990](BODY_FORCE_Z,0) = 0.000000; -NODES[3991](BODY_FORCE_X,0) = 0.000000; -NODES[3991](BODY_FORCE_Y,0) = -9.810000; -NODES[3991](BODY_FORCE_Z,0) = 0.000000; -NODES[3992](BODY_FORCE_X,0) = 0.000000; -NODES[3992](BODY_FORCE_Y,0) = -9.810000; -NODES[3992](BODY_FORCE_Z,0) = 0.000000; -NODES[3993](BODY_FORCE_X,0) = 0.000000; -NODES[3993](BODY_FORCE_Y,0) = -9.810000; -NODES[3993](BODY_FORCE_Z,0) = 0.000000; -NODES[3994](BODY_FORCE_X,0) = 0.000000; -NODES[3994](BODY_FORCE_Y,0) = -9.810000; -NODES[3994](BODY_FORCE_Z,0) = 0.000000; -NODES[3996](BODY_FORCE_X,0) = 0.000000; -NODES[3996](BODY_FORCE_Y,0) = -9.810000; -NODES[3996](BODY_FORCE_Z,0) = 0.000000; -NODES[3997](BODY_FORCE_X,0) = 0.000000; -NODES[3997](BODY_FORCE_Y,0) = -9.810000; -NODES[3997](BODY_FORCE_Z,0) = 0.000000; -NODES[3998](BODY_FORCE_X,0) = 0.000000; -NODES[3998](BODY_FORCE_Y,0) = -9.810000; -NODES[3998](BODY_FORCE_Z,0) = 0.000000; -NODES[3999](BODY_FORCE_X,0) = 0.000000; -NODES[3999](BODY_FORCE_Y,0) = -9.810000; -NODES[3999](BODY_FORCE_Z,0) = 0.000000; -NODES[4000](BODY_FORCE_X,0) = 0.000000; -NODES[4000](BODY_FORCE_Y,0) = -9.810000; -NODES[4000](BODY_FORCE_Z,0) = 0.000000; -NODES[4001](BODY_FORCE_X,0) = 0.000000; -NODES[4001](BODY_FORCE_Y,0) = -9.810000; -NODES[4001](BODY_FORCE_Z,0) = 0.000000; -NODES[4002](BODY_FORCE_X,0) = 0.000000; -NODES[4002](BODY_FORCE_Y,0) = -9.810000; -NODES[4002](BODY_FORCE_Z,0) = 0.000000; -NODES[4004](BODY_FORCE_X,0) = 0.000000; -NODES[4004](BODY_FORCE_Y,0) = -9.810000; -NODES[4004](BODY_FORCE_Z,0) = 0.000000; -NODES[4005](BODY_FORCE_X,0) = 0.000000; -NODES[4005](BODY_FORCE_Y,0) = -9.810000; -NODES[4005](BODY_FORCE_Z,0) = 0.000000; -NODES[4006](BODY_FORCE_X,0) = 0.000000; -NODES[4006](BODY_FORCE_Y,0) = -9.810000; -NODES[4006](BODY_FORCE_Z,0) = 0.000000; -NODES[4007](BODY_FORCE_X,0) = 0.000000; -NODES[4007](BODY_FORCE_Y,0) = -9.810000; -NODES[4007](BODY_FORCE_Z,0) = 0.000000; -NODES[4008](BODY_FORCE_X,0) = 0.000000; -NODES[4008](BODY_FORCE_Y,0) = -9.810000; -NODES[4008](BODY_FORCE_Z,0) = 0.000000; -NODES[4009](BODY_FORCE_X,0) = 0.000000; -NODES[4009](BODY_FORCE_Y,0) = -9.810000; -NODES[4009](BODY_FORCE_Z,0) = 0.000000; -NODES[4010](BODY_FORCE_X,0) = 0.000000; -NODES[4010](BODY_FORCE_Y,0) = -9.810000; -NODES[4010](BODY_FORCE_Z,0) = 0.000000; -NODES[4011](BODY_FORCE_X,0) = 0.000000; -NODES[4011](BODY_FORCE_Y,0) = -9.810000; -NODES[4011](BODY_FORCE_Z,0) = 0.000000; -NODES[4012](BODY_FORCE_X,0) = 0.000000; -NODES[4012](BODY_FORCE_Y,0) = -9.810000; -NODES[4012](BODY_FORCE_Z,0) = 0.000000; -NODES[4013](BODY_FORCE_X,0) = 0.000000; -NODES[4013](BODY_FORCE_Y,0) = -9.810000; -NODES[4013](BODY_FORCE_Z,0) = 0.000000; -NODES[4015](BODY_FORCE_X,0) = 0.000000; -NODES[4015](BODY_FORCE_Y,0) = -9.810000; -NODES[4015](BODY_FORCE_Z,0) = 0.000000; -NODES[4016](BODY_FORCE_X,0) = 0.000000; -NODES[4016](BODY_FORCE_Y,0) = -9.810000; -NODES[4016](BODY_FORCE_Z,0) = 0.000000; -NODES[4017](BODY_FORCE_X,0) = 0.000000; -NODES[4017](BODY_FORCE_Y,0) = -9.810000; -NODES[4017](BODY_FORCE_Z,0) = 0.000000; -NODES[4018](BODY_FORCE_X,0) = 0.000000; -NODES[4018](BODY_FORCE_Y,0) = -9.810000; -NODES[4018](BODY_FORCE_Z,0) = 0.000000; -NODES[4019](BODY_FORCE_X,0) = 0.000000; -NODES[4019](BODY_FORCE_Y,0) = -9.810000; -NODES[4019](BODY_FORCE_Z,0) = 0.000000; -NODES[4020](BODY_FORCE_X,0) = 0.000000; -NODES[4020](BODY_FORCE_Y,0) = -9.810000; -NODES[4020](BODY_FORCE_Z,0) = 0.000000; -NODES[4021](BODY_FORCE_X,0) = 0.000000; -NODES[4021](BODY_FORCE_Y,0) = -9.810000; -NODES[4021](BODY_FORCE_Z,0) = 0.000000; -NODES[4022](BODY_FORCE_X,0) = 0.000000; -NODES[4022](BODY_FORCE_Y,0) = -9.810000; -NODES[4022](BODY_FORCE_Z,0) = 0.000000; -NODES[4023](BODY_FORCE_X,0) = 0.000000; -NODES[4023](BODY_FORCE_Y,0) = -9.810000; -NODES[4023](BODY_FORCE_Z,0) = 0.000000; -NODES[4025](BODY_FORCE_X,0) = 0.000000; -NODES[4025](BODY_FORCE_Y,0) = -9.810000; -NODES[4025](BODY_FORCE_Z,0) = 0.000000; -NODES[4026](BODY_FORCE_X,0) = 0.000000; -NODES[4026](BODY_FORCE_Y,0) = -9.810000; -NODES[4026](BODY_FORCE_Z,0) = 0.000000; -NODES[4027](BODY_FORCE_X,0) = 0.000000; -NODES[4027](BODY_FORCE_Y,0) = -9.810000; -NODES[4027](BODY_FORCE_Z,0) = 0.000000; -NODES[4028](BODY_FORCE_X,0) = 0.000000; -NODES[4028](BODY_FORCE_Y,0) = -9.810000; -NODES[4028](BODY_FORCE_Z,0) = 0.000000; -NODES[4029](BODY_FORCE_X,0) = 0.000000; -NODES[4029](BODY_FORCE_Y,0) = -9.810000; -NODES[4029](BODY_FORCE_Z,0) = 0.000000; -NODES[4030](BODY_FORCE_X,0) = 0.000000; -NODES[4030](BODY_FORCE_Y,0) = -9.810000; -NODES[4030](BODY_FORCE_Z,0) = 0.000000; -NODES[4031](BODY_FORCE_X,0) = 0.000000; -NODES[4031](BODY_FORCE_Y,0) = -9.810000; -NODES[4031](BODY_FORCE_Z,0) = 0.000000; -NODES[4032](BODY_FORCE_X,0) = 0.000000; -NODES[4032](BODY_FORCE_Y,0) = -9.810000; -NODES[4032](BODY_FORCE_Z,0) = 0.000000; -NODES[4034](BODY_FORCE_X,0) = 0.000000; -NODES[4034](BODY_FORCE_Y,0) = -9.810000; -NODES[4034](BODY_FORCE_Z,0) = 0.000000; -NODES[4035](BODY_FORCE_X,0) = 0.000000; -NODES[4035](BODY_FORCE_Y,0) = -9.810000; -NODES[4035](BODY_FORCE_Z,0) = 0.000000; -NODES[4036](BODY_FORCE_X,0) = 0.000000; -NODES[4036](BODY_FORCE_Y,0) = -9.810000; -NODES[4036](BODY_FORCE_Z,0) = 0.000000; -NODES[4037](BODY_FORCE_X,0) = 0.000000; -NODES[4037](BODY_FORCE_Y,0) = -9.810000; -NODES[4037](BODY_FORCE_Z,0) = 0.000000; -NODES[4038](BODY_FORCE_X,0) = 0.000000; -NODES[4038](BODY_FORCE_Y,0) = -9.810000; -NODES[4038](BODY_FORCE_Z,0) = 0.000000; -NODES[4039](BODY_FORCE_X,0) = 0.000000; -NODES[4039](BODY_FORCE_Y,0) = -9.810000; -NODES[4039](BODY_FORCE_Z,0) = 0.000000; -NODES[4040](BODY_FORCE_X,0) = 0.000000; -NODES[4040](BODY_FORCE_Y,0) = -9.810000; -NODES[4040](BODY_FORCE_Z,0) = 0.000000; -NODES[4041](BODY_FORCE_X,0) = 0.000000; -NODES[4041](BODY_FORCE_Y,0) = -9.810000; -NODES[4041](BODY_FORCE_Z,0) = 0.000000; -NODES[4042](BODY_FORCE_X,0) = 0.000000; -NODES[4042](BODY_FORCE_Y,0) = -9.810000; -NODES[4042](BODY_FORCE_Z,0) = 0.000000; -NODES[4043](BODY_FORCE_X,0) = 0.000000; -NODES[4043](BODY_FORCE_Y,0) = -9.810000; -NODES[4043](BODY_FORCE_Z,0) = 0.000000; -NODES[4045](BODY_FORCE_X,0) = 0.000000; -NODES[4045](BODY_FORCE_Y,0) = -9.810000; -NODES[4045](BODY_FORCE_Z,0) = 0.000000; -NODES[4046](BODY_FORCE_X,0) = 0.000000; -NODES[4046](BODY_FORCE_Y,0) = -9.810000; -NODES[4046](BODY_FORCE_Z,0) = 0.000000; -NODES[4047](BODY_FORCE_X,0) = 0.000000; -NODES[4047](BODY_FORCE_Y,0) = -9.810000; -NODES[4047](BODY_FORCE_Z,0) = 0.000000; -NODES[4048](BODY_FORCE_X,0) = 0.000000; -NODES[4048](BODY_FORCE_Y,0) = -9.810000; -NODES[4048](BODY_FORCE_Z,0) = 0.000000; -NODES[4049](BODY_FORCE_X,0) = 0.000000; -NODES[4049](BODY_FORCE_Y,0) = -9.810000; -NODES[4049](BODY_FORCE_Z,0) = 0.000000; -NODES[4050](BODY_FORCE_X,0) = 0.000000; -NODES[4050](BODY_FORCE_Y,0) = -9.810000; -NODES[4050](BODY_FORCE_Z,0) = 0.000000; -NODES[4051](BODY_FORCE_X,0) = 0.000000; -NODES[4051](BODY_FORCE_Y,0) = -9.810000; -NODES[4051](BODY_FORCE_Z,0) = 0.000000; -NODES[4052](BODY_FORCE_X,0) = 0.000000; -NODES[4052](BODY_FORCE_Y,0) = -9.810000; -NODES[4052](BODY_FORCE_Z,0) = 0.000000; -NODES[4054](BODY_FORCE_X,0) = 0.000000; -NODES[4054](BODY_FORCE_Y,0) = -9.810000; -NODES[4054](BODY_FORCE_Z,0) = 0.000000; -NODES[4055](BODY_FORCE_X,0) = 0.000000; -NODES[4055](BODY_FORCE_Y,0) = -9.810000; -NODES[4055](BODY_FORCE_Z,0) = 0.000000; -NODES[4056](BODY_FORCE_X,0) = 0.000000; -NODES[4056](BODY_FORCE_Y,0) = -9.810000; -NODES[4056](BODY_FORCE_Z,0) = 0.000000; -NODES[4057](BODY_FORCE_X,0) = 0.000000; -NODES[4057](BODY_FORCE_Y,0) = -9.810000; -NODES[4057](BODY_FORCE_Z,0) = 0.000000; -NODES[4058](BODY_FORCE_X,0) = 0.000000; -NODES[4058](BODY_FORCE_Y,0) = -9.810000; -NODES[4058](BODY_FORCE_Z,0) = 0.000000; -NODES[4059](BODY_FORCE_X,0) = 0.000000; -NODES[4059](BODY_FORCE_Y,0) = -9.810000; -NODES[4059](BODY_FORCE_Z,0) = 0.000000; -NODES[4060](BODY_FORCE_X,0) = 0.000000; -NODES[4060](BODY_FORCE_Y,0) = -9.810000; -NODES[4060](BODY_FORCE_Z,0) = 0.000000; -NODES[4061](BODY_FORCE_X,0) = 0.000000; -NODES[4061](BODY_FORCE_Y,0) = -9.810000; -NODES[4061](BODY_FORCE_Z,0) = 0.000000; -NODES[4062](BODY_FORCE_X,0) = 0.000000; -NODES[4062](BODY_FORCE_Y,0) = -9.810000; -NODES[4062](BODY_FORCE_Z,0) = 0.000000; -NODES[4063](BODY_FORCE_X,0) = 0.000000; -NODES[4063](BODY_FORCE_Y,0) = -9.810000; -NODES[4063](BODY_FORCE_Z,0) = 0.000000; -NODES[4064](BODY_FORCE_X,0) = 0.000000; -NODES[4064](BODY_FORCE_Y,0) = -9.810000; -NODES[4064](BODY_FORCE_Z,0) = 0.000000; -NODES[4066](BODY_FORCE_X,0) = 0.000000; -NODES[4066](BODY_FORCE_Y,0) = -9.810000; -NODES[4066](BODY_FORCE_Z,0) = 0.000000; -NODES[4067](BODY_FORCE_X,0) = 0.000000; -NODES[4067](BODY_FORCE_Y,0) = -9.810000; -NODES[4067](BODY_FORCE_Z,0) = 0.000000; -NODES[4068](BODY_FORCE_X,0) = 0.000000; -NODES[4068](BODY_FORCE_Y,0) = -9.810000; -NODES[4068](BODY_FORCE_Z,0) = 0.000000; -NODES[4069](BODY_FORCE_X,0) = 0.000000; -NODES[4069](BODY_FORCE_Y,0) = -9.810000; -NODES[4069](BODY_FORCE_Z,0) = 0.000000; -NODES[4070](BODY_FORCE_X,0) = 0.000000; -NODES[4070](BODY_FORCE_Y,0) = -9.810000; -NODES[4070](BODY_FORCE_Z,0) = 0.000000; -NODES[4071](BODY_FORCE_X,0) = 0.000000; -NODES[4071](BODY_FORCE_Y,0) = -9.810000; -NODES[4071](BODY_FORCE_Z,0) = 0.000000; -NODES[4073](BODY_FORCE_X,0) = 0.000000; -NODES[4073](BODY_FORCE_Y,0) = -9.810000; -NODES[4073](BODY_FORCE_Z,0) = 0.000000; -NODES[4074](BODY_FORCE_X,0) = 0.000000; -NODES[4074](BODY_FORCE_Y,0) = -9.810000; -NODES[4074](BODY_FORCE_Z,0) = 0.000000; -NODES[4075](BODY_FORCE_X,0) = 0.000000; -NODES[4075](BODY_FORCE_Y,0) = -9.810000; -NODES[4075](BODY_FORCE_Z,0) = 0.000000; -NODES[4076](BODY_FORCE_X,0) = 0.000000; -NODES[4076](BODY_FORCE_Y,0) = -9.810000; -NODES[4076](BODY_FORCE_Z,0) = 0.000000; -NODES[4077](BODY_FORCE_X,0) = 0.000000; -NODES[4077](BODY_FORCE_Y,0) = -9.810000; -NODES[4077](BODY_FORCE_Z,0) = 0.000000; -NODES[4078](BODY_FORCE_X,0) = 0.000000; -NODES[4078](BODY_FORCE_Y,0) = -9.810000; -NODES[4078](BODY_FORCE_Z,0) = 0.000000; -NODES[4079](BODY_FORCE_X,0) = 0.000000; -NODES[4079](BODY_FORCE_Y,0) = -9.810000; -NODES[4079](BODY_FORCE_Z,0) = 0.000000; -NODES[4080](BODY_FORCE_X,0) = 0.000000; -NODES[4080](BODY_FORCE_Y,0) = -9.810000; -NODES[4080](BODY_FORCE_Z,0) = 0.000000; -NODES[4081](BODY_FORCE_X,0) = 0.000000; -NODES[4081](BODY_FORCE_Y,0) = -9.810000; -NODES[4081](BODY_FORCE_Z,0) = 0.000000; -NODES[4082](BODY_FORCE_X,0) = 0.000000; -NODES[4082](BODY_FORCE_Y,0) = -9.810000; -NODES[4082](BODY_FORCE_Z,0) = 0.000000; -NODES[4083](BODY_FORCE_X,0) = 0.000000; -NODES[4083](BODY_FORCE_Y,0) = -9.810000; -NODES[4083](BODY_FORCE_Z,0) = 0.000000; -NODES[4084](BODY_FORCE_X,0) = 0.000000; -NODES[4084](BODY_FORCE_Y,0) = -9.810000; -NODES[4084](BODY_FORCE_Z,0) = 0.000000; -NODES[4085](BODY_FORCE_X,0) = 0.000000; -NODES[4085](BODY_FORCE_Y,0) = -9.810000; -NODES[4085](BODY_FORCE_Z,0) = 0.000000; -NODES[4087](BODY_FORCE_X,0) = 0.000000; -NODES[4087](BODY_FORCE_Y,0) = -9.810000; -NODES[4087](BODY_FORCE_Z,0) = 0.000000; -NODES[4088](BODY_FORCE_X,0) = 0.000000; -NODES[4088](BODY_FORCE_Y,0) = -9.810000; -NODES[4088](BODY_FORCE_Z,0) = 0.000000; -NODES[4089](BODY_FORCE_X,0) = 0.000000; -NODES[4089](BODY_FORCE_Y,0) = -9.810000; -NODES[4089](BODY_FORCE_Z,0) = 0.000000; -NODES[4090](BODY_FORCE_X,0) = 0.000000; -NODES[4090](BODY_FORCE_Y,0) = -9.810000; -NODES[4090](BODY_FORCE_Z,0) = 0.000000; -NODES[4091](BODY_FORCE_X,0) = 0.000000; -NODES[4091](BODY_FORCE_Y,0) = -9.810000; -NODES[4091](BODY_FORCE_Z,0) = 0.000000; -NODES[4092](BODY_FORCE_X,0) = 0.000000; -NODES[4092](BODY_FORCE_Y,0) = -9.810000; -NODES[4092](BODY_FORCE_Z,0) = 0.000000; -NODES[4093](BODY_FORCE_X,0) = 0.000000; -NODES[4093](BODY_FORCE_Y,0) = -9.810000; -NODES[4093](BODY_FORCE_Z,0) = 0.000000; -NODES[4095](BODY_FORCE_X,0) = 0.000000; -NODES[4095](BODY_FORCE_Y,0) = -9.810000; -NODES[4095](BODY_FORCE_Z,0) = 0.000000; -NODES[4096](BODY_FORCE_X,0) = 0.000000; -NODES[4096](BODY_FORCE_Y,0) = -9.810000; -NODES[4096](BODY_FORCE_Z,0) = 0.000000; -NODES[4097](BODY_FORCE_X,0) = 0.000000; -NODES[4097](BODY_FORCE_Y,0) = -9.810000; -NODES[4097](BODY_FORCE_Z,0) = 0.000000; -NODES[4098](BODY_FORCE_X,0) = 0.000000; -NODES[4098](BODY_FORCE_Y,0) = -9.810000; -NODES[4098](BODY_FORCE_Z,0) = 0.000000; -NODES[4099](BODY_FORCE_X,0) = 0.000000; -NODES[4099](BODY_FORCE_Y,0) = -9.810000; -NODES[4099](BODY_FORCE_Z,0) = 0.000000; -NODES[4100](BODY_FORCE_X,0) = 0.000000; -NODES[4100](BODY_FORCE_Y,0) = -9.810000; -NODES[4100](BODY_FORCE_Z,0) = 0.000000; -NODES[4101](BODY_FORCE_X,0) = 0.000000; -NODES[4101](BODY_FORCE_Y,0) = -9.810000; -NODES[4101](BODY_FORCE_Z,0) = 0.000000; -NODES[4102](BODY_FORCE_X,0) = 0.000000; -NODES[4102](BODY_FORCE_Y,0) = -9.810000; -NODES[4102](BODY_FORCE_Z,0) = 0.000000; -NODES[4103](BODY_FORCE_X,0) = 0.000000; -NODES[4103](BODY_FORCE_Y,0) = -9.810000; -NODES[4103](BODY_FORCE_Z,0) = 0.000000; -NODES[4104](BODY_FORCE_X,0) = 0.000000; -NODES[4104](BODY_FORCE_Y,0) = -9.810000; -NODES[4104](BODY_FORCE_Z,0) = 0.000000; -NODES[4105](BODY_FORCE_X,0) = 0.000000; -NODES[4105](BODY_FORCE_Y,0) = -9.810000; -NODES[4105](BODY_FORCE_Z,0) = 0.000000; -NODES[4107](BODY_FORCE_X,0) = 0.000000; -NODES[4107](BODY_FORCE_Y,0) = -9.810000; -NODES[4107](BODY_FORCE_Z,0) = 0.000000; -NODES[4108](BODY_FORCE_X,0) = 0.000000; -NODES[4108](BODY_FORCE_Y,0) = -9.810000; -NODES[4108](BODY_FORCE_Z,0) = 0.000000; -NODES[4109](BODY_FORCE_X,0) = 0.000000; -NODES[4109](BODY_FORCE_Y,0) = -9.810000; -NODES[4109](BODY_FORCE_Z,0) = 0.000000; -NODES[4110](BODY_FORCE_X,0) = 0.000000; -NODES[4110](BODY_FORCE_Y,0) = -9.810000; -NODES[4110](BODY_FORCE_Z,0) = 0.000000; -NODES[4111](BODY_FORCE_X,0) = 0.000000; -NODES[4111](BODY_FORCE_Y,0) = -9.810000; -NODES[4111](BODY_FORCE_Z,0) = 0.000000; -NODES[4112](BODY_FORCE_X,0) = 0.000000; -NODES[4112](BODY_FORCE_Y,0) = -9.810000; -NODES[4112](BODY_FORCE_Z,0) = 0.000000; -NODES[4113](BODY_FORCE_X,0) = 0.000000; -NODES[4113](BODY_FORCE_Y,0) = -9.810000; -NODES[4113](BODY_FORCE_Z,0) = 0.000000; -NODES[4114](BODY_FORCE_X,0) = 0.000000; -NODES[4114](BODY_FORCE_Y,0) = -9.810000; -NODES[4114](BODY_FORCE_Z,0) = 0.000000; -NODES[4115](BODY_FORCE_X,0) = 0.000000; -NODES[4115](BODY_FORCE_Y,0) = -9.810000; -NODES[4115](BODY_FORCE_Z,0) = 0.000000; -NODES[4116](BODY_FORCE_X,0) = 0.000000; -NODES[4116](BODY_FORCE_Y,0) = -9.810000; -NODES[4116](BODY_FORCE_Z,0) = 0.000000; -NODES[4117](BODY_FORCE_X,0) = 0.000000; -NODES[4117](BODY_FORCE_Y,0) = -9.810000; -NODES[4117](BODY_FORCE_Z,0) = 0.000000; -NODES[4119](BODY_FORCE_X,0) = 0.000000; -NODES[4119](BODY_FORCE_Y,0) = -9.810000; -NODES[4119](BODY_FORCE_Z,0) = 0.000000; -NODES[4120](BODY_FORCE_X,0) = 0.000000; -NODES[4120](BODY_FORCE_Y,0) = -9.810000; -NODES[4120](BODY_FORCE_Z,0) = 0.000000; -NODES[4121](BODY_FORCE_X,0) = 0.000000; -NODES[4121](BODY_FORCE_Y,0) = -9.810000; -NODES[4121](BODY_FORCE_Z,0) = 0.000000; -NODES[4122](BODY_FORCE_X,0) = 0.000000; -NODES[4122](BODY_FORCE_Y,0) = -9.810000; -NODES[4122](BODY_FORCE_Z,0) = 0.000000; -NODES[4123](BODY_FORCE_X,0) = 0.000000; -NODES[4123](BODY_FORCE_Y,0) = -9.810000; -NODES[4123](BODY_FORCE_Z,0) = 0.000000; -NODES[4124](BODY_FORCE_X,0) = 0.000000; -NODES[4124](BODY_FORCE_Y,0) = -9.810000; -NODES[4124](BODY_FORCE_Z,0) = 0.000000; -NODES[4125](BODY_FORCE_X,0) = 0.000000; -NODES[4125](BODY_FORCE_Y,0) = -9.810000; -NODES[4125](BODY_FORCE_Z,0) = 0.000000; -NODES[4126](BODY_FORCE_X,0) = 0.000000; -NODES[4126](BODY_FORCE_Y,0) = -9.810000; -NODES[4126](BODY_FORCE_Z,0) = 0.000000; -NODES[4127](BODY_FORCE_X,0) = 0.000000; -NODES[4127](BODY_FORCE_Y,0) = -9.810000; -NODES[4127](BODY_FORCE_Z,0) = 0.000000; -NODES[4129](BODY_FORCE_X,0) = 0.000000; -NODES[4129](BODY_FORCE_Y,0) = -9.810000; -NODES[4129](BODY_FORCE_Z,0) = 0.000000; -NODES[4130](BODY_FORCE_X,0) = 0.000000; -NODES[4130](BODY_FORCE_Y,0) = -9.810000; -NODES[4130](BODY_FORCE_Z,0) = 0.000000; -NODES[4131](BODY_FORCE_X,0) = 0.000000; -NODES[4131](BODY_FORCE_Y,0) = -9.810000; -NODES[4131](BODY_FORCE_Z,0) = 0.000000; -NODES[4132](BODY_FORCE_X,0) = 0.000000; -NODES[4132](BODY_FORCE_Y,0) = -9.810000; -NODES[4132](BODY_FORCE_Z,0) = 0.000000; -NODES[4133](BODY_FORCE_X,0) = 0.000000; -NODES[4133](BODY_FORCE_Y,0) = -9.810000; -NODES[4133](BODY_FORCE_Z,0) = 0.000000; -NODES[4134](BODY_FORCE_X,0) = 0.000000; -NODES[4134](BODY_FORCE_Y,0) = -9.810000; -NODES[4134](BODY_FORCE_Z,0) = 0.000000; -NODES[4135](BODY_FORCE_X,0) = 0.000000; -NODES[4135](BODY_FORCE_Y,0) = -9.810000; -NODES[4135](BODY_FORCE_Z,0) = 0.000000; -NODES[4136](BODY_FORCE_X,0) = 0.000000; -NODES[4136](BODY_FORCE_Y,0) = -9.810000; -NODES[4136](BODY_FORCE_Z,0) = 0.000000; -NODES[4137](BODY_FORCE_X,0) = 0.000000; -NODES[4137](BODY_FORCE_Y,0) = -9.810000; -NODES[4137](BODY_FORCE_Z,0) = 0.000000; -NODES[4138](BODY_FORCE_X,0) = 0.000000; -NODES[4138](BODY_FORCE_Y,0) = -9.810000; -NODES[4138](BODY_FORCE_Z,0) = 0.000000; -NODES[4140](BODY_FORCE_X,0) = 0.000000; -NODES[4140](BODY_FORCE_Y,0) = -9.810000; -NODES[4140](BODY_FORCE_Z,0) = 0.000000; -NODES[4141](BODY_FORCE_X,0) = 0.000000; -NODES[4141](BODY_FORCE_Y,0) = -9.810000; -NODES[4141](BODY_FORCE_Z,0) = 0.000000; -NODES[4142](BODY_FORCE_X,0) = 0.000000; -NODES[4142](BODY_FORCE_Y,0) = -9.810000; -NODES[4142](BODY_FORCE_Z,0) = 0.000000; -NODES[4143](BODY_FORCE_X,0) = 0.000000; -NODES[4143](BODY_FORCE_Y,0) = -9.810000; -NODES[4143](BODY_FORCE_Z,0) = 0.000000; -NODES[4144](BODY_FORCE_X,0) = 0.000000; -NODES[4144](BODY_FORCE_Y,0) = -9.810000; -NODES[4144](BODY_FORCE_Z,0) = 0.000000; -NODES[4145](BODY_FORCE_X,0) = 0.000000; -NODES[4145](BODY_FORCE_Y,0) = -9.810000; -NODES[4145](BODY_FORCE_Z,0) = 0.000000; -NODES[4146](BODY_FORCE_X,0) = 0.000000; -NODES[4146](BODY_FORCE_Y,0) = -9.810000; -NODES[4146](BODY_FORCE_Z,0) = 0.000000; -NODES[4147](BODY_FORCE_X,0) = 0.000000; -NODES[4147](BODY_FORCE_Y,0) = -9.810000; -NODES[4147](BODY_FORCE_Z,0) = 0.000000; -NODES[4148](BODY_FORCE_X,0) = 0.000000; -NODES[4148](BODY_FORCE_Y,0) = -9.810000; -NODES[4148](BODY_FORCE_Z,0) = 0.000000; -NODES[4150](BODY_FORCE_X,0) = 0.000000; -NODES[4150](BODY_FORCE_Y,0) = -9.810000; -NODES[4150](BODY_FORCE_Z,0) = 0.000000; -NODES[4151](BODY_FORCE_X,0) = 0.000000; -NODES[4151](BODY_FORCE_Y,0) = -9.810000; -NODES[4151](BODY_FORCE_Z,0) = 0.000000; -NODES[4152](BODY_FORCE_X,0) = 0.000000; -NODES[4152](BODY_FORCE_Y,0) = -9.810000; -NODES[4152](BODY_FORCE_Z,0) = 0.000000; -NODES[4153](BODY_FORCE_X,0) = 0.000000; -NODES[4153](BODY_FORCE_Y,0) = -9.810000; -NODES[4153](BODY_FORCE_Z,0) = 0.000000; -NODES[4154](BODY_FORCE_X,0) = 0.000000; -NODES[4154](BODY_FORCE_Y,0) = -9.810000; -NODES[4154](BODY_FORCE_Z,0) = 0.000000; -NODES[4155](BODY_FORCE_X,0) = 0.000000; -NODES[4155](BODY_FORCE_Y,0) = -9.810000; -NODES[4155](BODY_FORCE_Z,0) = 0.000000; -NODES[4156](BODY_FORCE_X,0) = 0.000000; -NODES[4156](BODY_FORCE_Y,0) = -9.810000; -NODES[4156](BODY_FORCE_Z,0) = 0.000000; -NODES[4157](BODY_FORCE_X,0) = 0.000000; -NODES[4157](BODY_FORCE_Y,0) = -9.810000; -NODES[4157](BODY_FORCE_Z,0) = 0.000000; -NODES[4158](BODY_FORCE_X,0) = 0.000000; -NODES[4158](BODY_FORCE_Y,0) = -9.810000; -NODES[4158](BODY_FORCE_Z,0) = 0.000000; -NODES[4159](BODY_FORCE_X,0) = 0.000000; -NODES[4159](BODY_FORCE_Y,0) = -9.810000; -NODES[4159](BODY_FORCE_Z,0) = 0.000000; -NODES[4160](BODY_FORCE_X,0) = 0.000000; -NODES[4160](BODY_FORCE_Y,0) = -9.810000; -NODES[4160](BODY_FORCE_Z,0) = 0.000000; -NODES[4161](BODY_FORCE_X,0) = 0.000000; -NODES[4161](BODY_FORCE_Y,0) = -9.810000; -NODES[4161](BODY_FORCE_Z,0) = 0.000000; -NODES[4162](BODY_FORCE_X,0) = 0.000000; -NODES[4162](BODY_FORCE_Y,0) = -9.810000; -NODES[4162](BODY_FORCE_Z,0) = 0.000000; -NODES[4164](BODY_FORCE_X,0) = 0.000000; -NODES[4164](BODY_FORCE_Y,0) = -9.810000; -NODES[4164](BODY_FORCE_Z,0) = 0.000000; -NODES[4165](BODY_FORCE_X,0) = 0.000000; -NODES[4165](BODY_FORCE_Y,0) = -9.810000; -NODES[4165](BODY_FORCE_Z,0) = 0.000000; -NODES[4166](BODY_FORCE_X,0) = 0.000000; -NODES[4166](BODY_FORCE_Y,0) = -9.810000; -NODES[4166](BODY_FORCE_Z,0) = 0.000000; -NODES[4167](BODY_FORCE_X,0) = 0.000000; -NODES[4167](BODY_FORCE_Y,0) = -9.810000; -NODES[4167](BODY_FORCE_Z,0) = 0.000000; -NODES[4168](BODY_FORCE_X,0) = 0.000000; -NODES[4168](BODY_FORCE_Y,0) = -9.810000; -NODES[4168](BODY_FORCE_Z,0) = 0.000000; -NODES[4169](BODY_FORCE_X,0) = 0.000000; -NODES[4169](BODY_FORCE_Y,0) = -9.810000; -NODES[4169](BODY_FORCE_Z,0) = 0.000000; -NODES[4170](BODY_FORCE_X,0) = 0.000000; -NODES[4170](BODY_FORCE_Y,0) = -9.810000; -NODES[4170](BODY_FORCE_Z,0) = 0.000000; -NODES[4171](BODY_FORCE_X,0) = 0.000000; -NODES[4171](BODY_FORCE_Y,0) = -9.810000; -NODES[4171](BODY_FORCE_Z,0) = 0.000000; -NODES[4172](BODY_FORCE_X,0) = 0.000000; -NODES[4172](BODY_FORCE_Y,0) = -9.810000; -NODES[4172](BODY_FORCE_Z,0) = 0.000000; -NODES[4174](BODY_FORCE_X,0) = 0.000000; -NODES[4174](BODY_FORCE_Y,0) = -9.810000; -NODES[4174](BODY_FORCE_Z,0) = 0.000000; -NODES[4175](BODY_FORCE_X,0) = 0.000000; -NODES[4175](BODY_FORCE_Y,0) = -9.810000; -NODES[4175](BODY_FORCE_Z,0) = 0.000000; -NODES[4176](BODY_FORCE_X,0) = 0.000000; -NODES[4176](BODY_FORCE_Y,0) = -9.810000; -NODES[4176](BODY_FORCE_Z,0) = 0.000000; -NODES[4177](BODY_FORCE_X,0) = 0.000000; -NODES[4177](BODY_FORCE_Y,0) = -9.810000; -NODES[4177](BODY_FORCE_Z,0) = 0.000000; -NODES[4178](BODY_FORCE_X,0) = 0.000000; -NODES[4178](BODY_FORCE_Y,0) = -9.810000; -NODES[4178](BODY_FORCE_Z,0) = 0.000000; -NODES[4179](BODY_FORCE_X,0) = 0.000000; -NODES[4179](BODY_FORCE_Y,0) = -9.810000; -NODES[4179](BODY_FORCE_Z,0) = 0.000000; -NODES[4180](BODY_FORCE_X,0) = 0.000000; -NODES[4180](BODY_FORCE_Y,0) = -9.810000; -NODES[4180](BODY_FORCE_Z,0) = 0.000000; -NODES[4181](BODY_FORCE_X,0) = 0.000000; -NODES[4181](BODY_FORCE_Y,0) = -9.810000; -NODES[4181](BODY_FORCE_Z,0) = 0.000000; -NODES[4182](BODY_FORCE_X,0) = 0.000000; -NODES[4182](BODY_FORCE_Y,0) = -9.810000; -NODES[4182](BODY_FORCE_Z,0) = 0.000000; -NODES[4183](BODY_FORCE_X,0) = 0.000000; -NODES[4183](BODY_FORCE_Y,0) = -9.810000; -NODES[4183](BODY_FORCE_Z,0) = 0.000000; -NODES[4184](BODY_FORCE_X,0) = 0.000000; -NODES[4184](BODY_FORCE_Y,0) = -9.810000; -NODES[4184](BODY_FORCE_Z,0) = 0.000000; -NODES[4185](BODY_FORCE_X,0) = 0.000000; -NODES[4185](BODY_FORCE_Y,0) = -9.810000; -NODES[4185](BODY_FORCE_Z,0) = 0.000000; -NODES[4186](BODY_FORCE_X,0) = 0.000000; -NODES[4186](BODY_FORCE_Y,0) = -9.810000; -NODES[4186](BODY_FORCE_Z,0) = 0.000000; -NODES[4187](BODY_FORCE_X,0) = 0.000000; -NODES[4187](BODY_FORCE_Y,0) = -9.810000; -NODES[4187](BODY_FORCE_Z,0) = 0.000000; -NODES[4188](BODY_FORCE_X,0) = 0.000000; -NODES[4188](BODY_FORCE_Y,0) = -9.810000; -NODES[4188](BODY_FORCE_Z,0) = 0.000000; -NODES[4189](BODY_FORCE_X,0) = 0.000000; -NODES[4189](BODY_FORCE_Y,0) = -9.810000; -NODES[4189](BODY_FORCE_Z,0) = 0.000000; -NODES[4190](BODY_FORCE_X,0) = 0.000000; -NODES[4190](BODY_FORCE_Y,0) = -9.810000; -NODES[4190](BODY_FORCE_Z,0) = 0.000000; -NODES[4191](BODY_FORCE_X,0) = 0.000000; -NODES[4191](BODY_FORCE_Y,0) = -9.810000; -NODES[4191](BODY_FORCE_Z,0) = 0.000000; -NODES[4192](BODY_FORCE_X,0) = 0.000000; -NODES[4192](BODY_FORCE_Y,0) = -9.810000; -NODES[4192](BODY_FORCE_Z,0) = 0.000000; -NODES[4193](BODY_FORCE_X,0) = 0.000000; -NODES[4193](BODY_FORCE_Y,0) = -9.810000; -NODES[4193](BODY_FORCE_Z,0) = 0.000000; -NODES[4194](BODY_FORCE_X,0) = 0.000000; -NODES[4194](BODY_FORCE_Y,0) = -9.810000; -NODES[4194](BODY_FORCE_Z,0) = 0.000000; -NODES[4195](BODY_FORCE_X,0) = 0.000000; -NODES[4195](BODY_FORCE_Y,0) = -9.810000; -NODES[4195](BODY_FORCE_Z,0) = 0.000000; -NODES[4196](BODY_FORCE_X,0) = 0.000000; -NODES[4196](BODY_FORCE_Y,0) = -9.810000; -NODES[4196](BODY_FORCE_Z,0) = 0.000000; -NODES[4197](BODY_FORCE_X,0) = 0.000000; -NODES[4197](BODY_FORCE_Y,0) = -9.810000; -NODES[4197](BODY_FORCE_Z,0) = 0.000000; -NODES[4198](BODY_FORCE_X,0) = 0.000000; -NODES[4198](BODY_FORCE_Y,0) = -9.810000; -NODES[4198](BODY_FORCE_Z,0) = 0.000000; -NODES[4199](BODY_FORCE_X,0) = 0.000000; -NODES[4199](BODY_FORCE_Y,0) = -9.810000; -NODES[4199](BODY_FORCE_Z,0) = 0.000000; -NODES[4200](BODY_FORCE_X,0) = 0.000000; -NODES[4200](BODY_FORCE_Y,0) = -9.810000; -NODES[4200](BODY_FORCE_Z,0) = 0.000000; -NODES[4201](BODY_FORCE_X,0) = 0.000000; -NODES[4201](BODY_FORCE_Y,0) = -9.810000; -NODES[4201](BODY_FORCE_Z,0) = 0.000000; -NODES[4202](BODY_FORCE_X,0) = 0.000000; -NODES[4202](BODY_FORCE_Y,0) = -9.810000; -NODES[4202](BODY_FORCE_Z,0) = 0.000000; -NODES[4203](BODY_FORCE_X,0) = 0.000000; -NODES[4203](BODY_FORCE_Y,0) = -9.810000; -NODES[4203](BODY_FORCE_Z,0) = 0.000000; -NODES[4204](BODY_FORCE_X,0) = 0.000000; -NODES[4204](BODY_FORCE_Y,0) = -9.810000; -NODES[4204](BODY_FORCE_Z,0) = 0.000000; -NODES[4205](BODY_FORCE_X,0) = 0.000000; -NODES[4205](BODY_FORCE_Y,0) = -9.810000; -NODES[4205](BODY_FORCE_Z,0) = 0.000000; -NODES[4206](BODY_FORCE_X,0) = 0.000000; -NODES[4206](BODY_FORCE_Y,0) = -9.810000; -NODES[4206](BODY_FORCE_Z,0) = 0.000000; -NODES[4207](BODY_FORCE_X,0) = 0.000000; -NODES[4207](BODY_FORCE_Y,0) = -9.810000; -NODES[4207](BODY_FORCE_Z,0) = 0.000000; -NODES[4208](BODY_FORCE_X,0) = 0.000000; -NODES[4208](BODY_FORCE_Y,0) = -9.810000; -NODES[4208](BODY_FORCE_Z,0) = 0.000000; -NODES[4209](BODY_FORCE_X,0) = 0.000000; -NODES[4209](BODY_FORCE_Y,0) = -9.810000; -NODES[4209](BODY_FORCE_Z,0) = 0.000000; -NODES[4210](BODY_FORCE_X,0) = 0.000000; -NODES[4210](BODY_FORCE_Y,0) = -9.810000; -NODES[4210](BODY_FORCE_Z,0) = 0.000000; -NODES[4211](BODY_FORCE_X,0) = 0.000000; -NODES[4211](BODY_FORCE_Y,0) = -9.810000; -NODES[4211](BODY_FORCE_Z,0) = 0.000000; -NODES[4212](BODY_FORCE_X,0) = 0.000000; -NODES[4212](BODY_FORCE_Y,0) = -9.810000; -NODES[4212](BODY_FORCE_Z,0) = 0.000000; -NODES[4213](BODY_FORCE_X,0) = 0.000000; -NODES[4213](BODY_FORCE_Y,0) = -9.810000; -NODES[4213](BODY_FORCE_Z,0) = 0.000000; -NODES[4214](BODY_FORCE_X,0) = 0.000000; -NODES[4214](BODY_FORCE_Y,0) = -9.810000; -NODES[4214](BODY_FORCE_Z,0) = 0.000000; -NODES[4215](BODY_FORCE_X,0) = 0.000000; -NODES[4215](BODY_FORCE_Y,0) = -9.810000; -NODES[4215](BODY_FORCE_Z,0) = 0.000000; -NODES[4216](BODY_FORCE_X,0) = 0.000000; -NODES[4216](BODY_FORCE_Y,0) = -9.810000; -NODES[4216](BODY_FORCE_Z,0) = 0.000000; -NODES[4217](BODY_FORCE_X,0) = 0.000000; -NODES[4217](BODY_FORCE_Y,0) = -9.810000; -NODES[4217](BODY_FORCE_Z,0) = 0.000000; -NODES[4218](BODY_FORCE_X,0) = 0.000000; -NODES[4218](BODY_FORCE_Y,0) = -9.810000; -NODES[4218](BODY_FORCE_Z,0) = 0.000000; -NODES[4219](BODY_FORCE_X,0) = 0.000000; -NODES[4219](BODY_FORCE_Y,0) = -9.810000; -NODES[4219](BODY_FORCE_Z,0) = 0.000000; -NODES[4220](BODY_FORCE_X,0) = 0.000000; -NODES[4220](BODY_FORCE_Y,0) = -9.810000; -NODES[4220](BODY_FORCE_Z,0) = 0.000000; -NODES[4221](BODY_FORCE_X,0) = 0.000000; -NODES[4221](BODY_FORCE_Y,0) = -9.810000; -NODES[4221](BODY_FORCE_Z,0) = 0.000000; -NODES[4222](BODY_FORCE_X,0) = 0.000000; -NODES[4222](BODY_FORCE_Y,0) = -9.810000; -NODES[4222](BODY_FORCE_Z,0) = 0.000000; -NODES[4223](BODY_FORCE_X,0) = 0.000000; -NODES[4223](BODY_FORCE_Y,0) = -9.810000; -NODES[4223](BODY_FORCE_Z,0) = 0.000000; -NODES[4224](BODY_FORCE_X,0) = 0.000000; -NODES[4224](BODY_FORCE_Y,0) = -9.810000; -NODES[4224](BODY_FORCE_Z,0) = 0.000000; -NODES[4225](BODY_FORCE_X,0) = 0.000000; -NODES[4225](BODY_FORCE_Y,0) = -9.810000; -NODES[4225](BODY_FORCE_Z,0) = 0.000000; -NODES[4226](BODY_FORCE_X,0) = 0.000000; -NODES[4226](BODY_FORCE_Y,0) = -9.810000; -NODES[4226](BODY_FORCE_Z,0) = 0.000000; -NODES[4227](BODY_FORCE_X,0) = 0.000000; -NODES[4227](BODY_FORCE_Y,0) = -9.810000; -NODES[4227](BODY_FORCE_Z,0) = 0.000000; -NODES[4228](BODY_FORCE_X,0) = 0.000000; -NODES[4228](BODY_FORCE_Y,0) = -9.810000; -NODES[4228](BODY_FORCE_Z,0) = 0.000000; -NODES[4229](BODY_FORCE_X,0) = 0.000000; -NODES[4229](BODY_FORCE_Y,0) = -9.810000; -NODES[4229](BODY_FORCE_Z,0) = 0.000000; -NODES[4230](BODY_FORCE_X,0) = 0.000000; -NODES[4230](BODY_FORCE_Y,0) = -9.810000; -NODES[4230](BODY_FORCE_Z,0) = 0.000000; -NODES[4231](BODY_FORCE_X,0) = 0.000000; -NODES[4231](BODY_FORCE_Y,0) = -9.810000; -NODES[4231](BODY_FORCE_Z,0) = 0.000000; -NODES[4232](BODY_FORCE_X,0) = 0.000000; -NODES[4232](BODY_FORCE_Y,0) = -9.810000; -NODES[4232](BODY_FORCE_Z,0) = 0.000000; -NODES[4233](BODY_FORCE_X,0) = 0.000000; -NODES[4233](BODY_FORCE_Y,0) = -9.810000; -NODES[4233](BODY_FORCE_Z,0) = 0.000000; -NODES[4234](BODY_FORCE_X,0) = 0.000000; -NODES[4234](BODY_FORCE_Y,0) = -9.810000; -NODES[4234](BODY_FORCE_Z,0) = 0.000000; -NODES[4235](BODY_FORCE_X,0) = 0.000000; -NODES[4235](BODY_FORCE_Y,0) = -9.810000; -NODES[4235](BODY_FORCE_Z,0) = 0.000000; -NODES[4236](BODY_FORCE_X,0) = 0.000000; -NODES[4236](BODY_FORCE_Y,0) = -9.810000; -NODES[4236](BODY_FORCE_Z,0) = 0.000000; -NODES[4237](BODY_FORCE_X,0) = 0.000000; -NODES[4237](BODY_FORCE_Y,0) = -9.810000; -NODES[4237](BODY_FORCE_Z,0) = 0.000000; -NODES[4238](BODY_FORCE_X,0) = 0.000000; -NODES[4238](BODY_FORCE_Y,0) = -9.810000; -NODES[4238](BODY_FORCE_Z,0) = 0.000000; -NODES[4239](BODY_FORCE_X,0) = 0.000000; -NODES[4239](BODY_FORCE_Y,0) = -9.810000; -NODES[4239](BODY_FORCE_Z,0) = 0.000000; -NODES[4240](BODY_FORCE_X,0) = 0.000000; -NODES[4240](BODY_FORCE_Y,0) = -9.810000; -NODES[4240](BODY_FORCE_Z,0) = 0.000000; -NODES[4241](BODY_FORCE_X,0) = 0.000000; -NODES[4241](BODY_FORCE_Y,0) = -9.810000; -NODES[4241](BODY_FORCE_Z,0) = 0.000000; -NODES[4242](BODY_FORCE_X,0) = 0.000000; -NODES[4242](BODY_FORCE_Y,0) = -9.810000; -NODES[4242](BODY_FORCE_Z,0) = 0.000000; -NODES[4243](BODY_FORCE_X,0) = 0.000000; -NODES[4243](BODY_FORCE_Y,0) = -9.810000; -NODES[4243](BODY_FORCE_Z,0) = 0.000000; -NODES[4244](BODY_FORCE_X,0) = 0.000000; -NODES[4244](BODY_FORCE_Y,0) = -9.810000; -NODES[4244](BODY_FORCE_Z,0) = 0.000000; -NODES[4245](BODY_FORCE_X,0) = 0.000000; -NODES[4245](BODY_FORCE_Y,0) = -9.810000; -NODES[4245](BODY_FORCE_Z,0) = 0.000000; -NODES[4246](BODY_FORCE_X,0) = 0.000000; -NODES[4246](BODY_FORCE_Y,0) = -9.810000; -NODES[4246](BODY_FORCE_Z,0) = 0.000000; -NODES[4247](BODY_FORCE_X,0) = 0.000000; -NODES[4247](BODY_FORCE_Y,0) = -9.810000; -NODES[4247](BODY_FORCE_Z,0) = 0.000000; -NODES[4248](BODY_FORCE_X,0) = 0.000000; -NODES[4248](BODY_FORCE_Y,0) = -9.810000; -NODES[4248](BODY_FORCE_Z,0) = 0.000000; -NODES[4249](BODY_FORCE_X,0) = 0.000000; -NODES[4249](BODY_FORCE_Y,0) = -9.810000; -NODES[4249](BODY_FORCE_Z,0) = 0.000000; -NODES[4250](BODY_FORCE_X,0) = 0.000000; -NODES[4250](BODY_FORCE_Y,0) = -9.810000; -NODES[4250](BODY_FORCE_Z,0) = 0.000000; -NODES[4251](BODY_FORCE_X,0) = 0.000000; -NODES[4251](BODY_FORCE_Y,0) = -9.810000; -NODES[4251](BODY_FORCE_Z,0) = 0.000000; -NODES[4252](BODY_FORCE_X,0) = 0.000000; -NODES[4252](BODY_FORCE_Y,0) = -9.810000; -NODES[4252](BODY_FORCE_Z,0) = 0.000000; -NODES[4253](BODY_FORCE_X,0) = 0.000000; -NODES[4253](BODY_FORCE_Y,0) = -9.810000; -NODES[4253](BODY_FORCE_Z,0) = 0.000000; -NODES[4254](BODY_FORCE_X,0) = 0.000000; -NODES[4254](BODY_FORCE_Y,0) = -9.810000; -NODES[4254](BODY_FORCE_Z,0) = 0.000000; -NODES[4255](BODY_FORCE_X,0) = 0.000000; -NODES[4255](BODY_FORCE_Y,0) = -9.810000; -NODES[4255](BODY_FORCE_Z,0) = 0.000000; -NODES[4256](BODY_FORCE_X,0) = 0.000000; -NODES[4256](BODY_FORCE_Y,0) = -9.810000; -NODES[4256](BODY_FORCE_Z,0) = 0.000000; -NODES[4257](BODY_FORCE_X,0) = 0.000000; -NODES[4257](BODY_FORCE_Y,0) = -9.810000; -NODES[4257](BODY_FORCE_Z,0) = 0.000000; -NODES[4258](BODY_FORCE_X,0) = 0.000000; -NODES[4258](BODY_FORCE_Y,0) = -9.810000; -NODES[4258](BODY_FORCE_Z,0) = 0.000000; -NODES[4259](BODY_FORCE_X,0) = 0.000000; -NODES[4259](BODY_FORCE_Y,0) = -9.810000; -NODES[4259](BODY_FORCE_Z,0) = 0.000000; -NODES[4260](BODY_FORCE_X,0) = 0.000000; -NODES[4260](BODY_FORCE_Y,0) = -9.810000; -NODES[4260](BODY_FORCE_Z,0) = 0.000000; -NODES[4261](BODY_FORCE_X,0) = 0.000000; -NODES[4261](BODY_FORCE_Y,0) = -9.810000; -NODES[4261](BODY_FORCE_Z,0) = 0.000000; -NODES[4262](BODY_FORCE_X,0) = 0.000000; -NODES[4262](BODY_FORCE_Y,0) = -9.810000; -NODES[4262](BODY_FORCE_Z,0) = 0.000000; -NODES[4263](BODY_FORCE_X,0) = 0.000000; -NODES[4263](BODY_FORCE_Y,0) = -9.810000; -NODES[4263](BODY_FORCE_Z,0) = 0.000000; -NODES[4264](BODY_FORCE_X,0) = 0.000000; -NODES[4264](BODY_FORCE_Y,0) = -9.810000; -NODES[4264](BODY_FORCE_Z,0) = 0.000000; -NODES[4265](BODY_FORCE_X,0) = 0.000000; -NODES[4265](BODY_FORCE_Y,0) = -9.810000; -NODES[4265](BODY_FORCE_Z,0) = 0.000000; -NODES[4266](BODY_FORCE_X,0) = 0.000000; -NODES[4266](BODY_FORCE_Y,0) = -9.810000; -NODES[4266](BODY_FORCE_Z,0) = 0.000000; -NODES[4267](BODY_FORCE_X,0) = 0.000000; -NODES[4267](BODY_FORCE_Y,0) = -9.810000; -NODES[4267](BODY_FORCE_Z,0) = 0.000000; -NODES[4268](BODY_FORCE_X,0) = 0.000000; -NODES[4268](BODY_FORCE_Y,0) = -9.810000; -NODES[4268](BODY_FORCE_Z,0) = 0.000000; -NODES[4269](BODY_FORCE_X,0) = 0.000000; -NODES[4269](BODY_FORCE_Y,0) = -9.810000; -NODES[4269](BODY_FORCE_Z,0) = 0.000000; -NODES[4270](BODY_FORCE_X,0) = 0.000000; -NODES[4270](BODY_FORCE_Y,0) = -9.810000; -NODES[4270](BODY_FORCE_Z,0) = 0.000000; -NODES[4271](BODY_FORCE_X,0) = 0.000000; -NODES[4271](BODY_FORCE_Y,0) = -9.810000; -NODES[4271](BODY_FORCE_Z,0) = 0.000000; -NODES[4272](BODY_FORCE_X,0) = 0.000000; -NODES[4272](BODY_FORCE_Y,0) = -9.810000; -NODES[4272](BODY_FORCE_Z,0) = 0.000000; -NODES[4273](BODY_FORCE_X,0) = 0.000000; -NODES[4273](BODY_FORCE_Y,0) = -9.810000; -NODES[4273](BODY_FORCE_Z,0) = 0.000000; -NODES[4274](BODY_FORCE_X,0) = 0.000000; -NODES[4274](BODY_FORCE_Y,0) = -9.810000; -NODES[4274](BODY_FORCE_Z,0) = 0.000000; -NODES[4275](BODY_FORCE_X,0) = 0.000000; -NODES[4275](BODY_FORCE_Y,0) = -9.810000; -NODES[4275](BODY_FORCE_Z,0) = 0.000000; -NODES[4276](BODY_FORCE_X,0) = 0.000000; -NODES[4276](BODY_FORCE_Y,0) = -9.810000; -NODES[4276](BODY_FORCE_Z,0) = 0.000000; -NODES[4277](BODY_FORCE_X,0) = 0.000000; -NODES[4277](BODY_FORCE_Y,0) = -9.810000; -NODES[4277](BODY_FORCE_Z,0) = 0.000000; -NODES[4278](BODY_FORCE_X,0) = 0.000000; -NODES[4278](BODY_FORCE_Y,0) = -9.810000; -NODES[4278](BODY_FORCE_Z,0) = 0.000000; -NODES[4279](BODY_FORCE_X,0) = 0.000000; -NODES[4279](BODY_FORCE_Y,0) = -9.810000; -NODES[4279](BODY_FORCE_Z,0) = 0.000000; -NODES[4280](BODY_FORCE_X,0) = 0.000000; -NODES[4280](BODY_FORCE_Y,0) = -9.810000; -NODES[4280](BODY_FORCE_Z,0) = 0.000000; -NODES[4281](BODY_FORCE_X,0) = 0.000000; -NODES[4281](BODY_FORCE_Y,0) = -9.810000; -NODES[4281](BODY_FORCE_Z,0) = 0.000000; -NODES[4282](BODY_FORCE_X,0) = 0.000000; -NODES[4282](BODY_FORCE_Y,0) = -9.810000; -NODES[4282](BODY_FORCE_Z,0) = 0.000000; -NODES[4283](BODY_FORCE_X,0) = 0.000000; -NODES[4283](BODY_FORCE_Y,0) = -9.810000; -NODES[4283](BODY_FORCE_Z,0) = 0.000000; -NODES[4284](BODY_FORCE_X,0) = 0.000000; -NODES[4284](BODY_FORCE_Y,0) = -9.810000; -NODES[4284](BODY_FORCE_Z,0) = 0.000000; -NODES[4285](BODY_FORCE_X,0) = 0.000000; -NODES[4285](BODY_FORCE_Y,0) = -9.810000; -NODES[4285](BODY_FORCE_Z,0) = 0.000000; -NODES[4286](BODY_FORCE_X,0) = 0.000000; -NODES[4286](BODY_FORCE_Y,0) = -9.810000; -NODES[4286](BODY_FORCE_Z,0) = 0.000000; -NODES[4287](BODY_FORCE_X,0) = 0.000000; -NODES[4287](BODY_FORCE_Y,0) = -9.810000; -NODES[4287](BODY_FORCE_Z,0) = 0.000000; -NODES[4288](BODY_FORCE_X,0) = 0.000000; -NODES[4288](BODY_FORCE_Y,0) = -9.810000; -NODES[4288](BODY_FORCE_Z,0) = 0.000000; -NODES[4289](BODY_FORCE_X,0) = 0.000000; -NODES[4289](BODY_FORCE_Y,0) = -9.810000; -NODES[4289](BODY_FORCE_Z,0) = 0.000000; -NODES[4290](BODY_FORCE_X,0) = 0.000000; -NODES[4290](BODY_FORCE_Y,0) = -9.810000; -NODES[4290](BODY_FORCE_Z,0) = 0.000000; -NODES[4291](BODY_FORCE_X,0) = 0.000000; -NODES[4291](BODY_FORCE_Y,0) = -9.810000; -NODES[4291](BODY_FORCE_Z,0) = 0.000000; -NODES[4292](BODY_FORCE_X,0) = 0.000000; -NODES[4292](BODY_FORCE_Y,0) = -9.810000; -NODES[4292](BODY_FORCE_Z,0) = 0.000000; -NODES[4293](BODY_FORCE_X,0) = 0.000000; -NODES[4293](BODY_FORCE_Y,0) = -9.810000; -NODES[4293](BODY_FORCE_Z,0) = 0.000000; -NODES[4294](BODY_FORCE_X,0) = 0.000000; -NODES[4294](BODY_FORCE_Y,0) = -9.810000; -NODES[4294](BODY_FORCE_Z,0) = 0.000000; -NODES[4295](BODY_FORCE_X,0) = 0.000000; -NODES[4295](BODY_FORCE_Y,0) = -9.810000; -NODES[4295](BODY_FORCE_Z,0) = 0.000000; -NODES[4296](BODY_FORCE_X,0) = 0.000000; -NODES[4296](BODY_FORCE_Y,0) = -9.810000; -NODES[4296](BODY_FORCE_Z,0) = 0.000000; -NODES[4297](BODY_FORCE_X,0) = 0.000000; -NODES[4297](BODY_FORCE_Y,0) = -9.810000; -NODES[4297](BODY_FORCE_Z,0) = 0.000000; -NODES[4298](BODY_FORCE_X,0) = 0.000000; -NODES[4298](BODY_FORCE_Y,0) = -9.810000; -NODES[4298](BODY_FORCE_Z,0) = 0.000000; -NODES[4299](BODY_FORCE_X,0) = 0.000000; -NODES[4299](BODY_FORCE_Y,0) = -9.810000; -NODES[4299](BODY_FORCE_Z,0) = 0.000000; diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.lin b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.lin deleted file mode 100644 index a2edfd4d7b55..000000000000 Binary files a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.lin and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.mat b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.mat deleted file mode 100644 index a41ed15b11bd..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.mat +++ /dev/null @@ -1,45 +0,0 @@ -BOOK:Fluid_Material -NUMBER: 1 MATERIAL: Air -QUESTION: ID#CB#(Fluid) -VALUE: Fluid -STATE: HIDDEN -QUESTION: Density -VALUE: 1.2 -QUESTION: Viscosity -VALUE: 0.000017 -QUESTION: gravity -VALUE: 0 -END MATERIAL -NUMBER: 2 MATERIAL: StrucMat -QUESTION: ID#CB#(Fluid) -VALUE: Fluid -STATE: HIDDEN -QUESTION: Density -VALUE: 2700 -QUESTION: Viscosity -VALUE: 0.000017 -QUESTION: gravity -VALUE: 0 -END MATERIAL -NUMBER: 3 MATERIAL: Aluminum -QUESTION: ID#CB#(Fluid) -VALUE: Fluid -STATE: HIDDEN -QUESTION: Density -VALUE: 2700 -QUESTION: Viscosity -VALUE: 0.000017 -QUESTION: gravity -VALUE: 0 -END MATERIAL -NUMBER: 4 MATERIAL: Water -QUESTION: ID#CB#(Fluid) -VALUE: Fluid -STATE: HIDDEN -QUESTION: Density -VALUE: 1.2 -QUESTION: Viscosity -VALUE: 0.000017 -QUESTION: gravity -VALUE: 0 -END MATERIAL diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.msh b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.msh deleted file mode 100644 index fb8c7c34faee..000000000000 Binary files a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.msh and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.node b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.node deleted file mode 100644 index 62c2ae97f0a3..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.node +++ /dev/null @@ -1,4302 +0,0 @@ -NODES = NodesList([ -[1, 0.90000, 0.50800, 0.00000], -[2, 0.90000, 0.50300, 0.00000], -[3, 0.89500, 0.50800, 0.00000], -[4, 0.90000, 0.49800, 0.00000], -[5, 0.89000, 0.50800, 0.00000], -[6, 0.90000, 0.49300, 0.00000], -[7, 0.88500, 0.50800, 0.00000], -[8, 0.90000, 0.48800, 0.00000], -[9, 0.88000, 0.50800, 0.00000], -[10, 0.90000, 0.48300, 0.00000], -[11, 0.87500, 0.50800, 0.00000], -[12, 0.90000, 0.47803, 0.00000], -[13, 0.87000, 0.50800, 0.00000], -[14, 0.90000, 0.47305, 0.00000], -[15, 0.86500, 0.50800, 0.00000], -[16, 0.90000, 0.46808, 0.00000], -[17, 0.86000, 0.50800, 0.00000], -[18, 0.90000, 0.46311, 0.00000], -[19, 0.85500, 0.50800, 0.00000], -[20, 0.90000, 0.45814, 0.00000], -[21, 0.85000, 0.50800, 0.00000], -[22, 0.90000, 0.45316, 0.00000], -[23, 0.84500, 0.50800, 0.00000], -[24, 0.90000, 0.44819, 0.00000], -[25, 0.84000, 0.50800, 0.00000], -[26, 0.90000, 0.44322, 0.00000], -[27, 0.83500, 0.50800, 0.00000], -[28, 0.90000, 0.43824, 0.00000], -[29, 0.83000, 0.50800, 0.00000], -[30, 0.90000, 0.43327, 0.00000], -[31, 0.82500, 0.50800, 0.00000], -[32, 0.90000, 0.42830, 0.00000], -[33, 0.82000, 0.50800, 0.00000], -[34, 0.90000, 0.42332, 0.00000], -[35, 0.81500, 0.50800, 0.00000], -[36, 0.90000, 0.41835, 0.00000], -[37, 0.81000, 0.50800, 0.00000], -[38, 0.90000, 0.41338, 0.00000], -[39, 0.80500, 0.50800, 0.00000], -[40, 0.90000, 0.40841, 0.00000], -[41, 0.80000, 0.50800, 0.00000], -[42, 0.90000, 0.40343, 0.00000], -[43, 0.79500, 0.50800, 0.00000], -[44, 0.90000, 0.39846, 0.00000], -[45, 0.79000, 0.50800, 0.00000], -[46, 0.90000, 0.39349, 0.00000], -[47, 0.78500, 0.50800, 0.00000], -[48, 0.90000, 0.38851, 0.00000], -[49, 0.78000, 0.50800, 0.00000], -[50, 0.90000, 0.38354, 0.00000], -[51, 0.77500, 0.50800, 0.00000], -[52, 0.90000, 0.37857, 0.00000], -[53, 0.77000, 0.50800, 0.00000], -[54, 0.90000, 0.37359, 0.00000], -[55, 0.76500, 0.50800, 0.00000], -[56, 0.90000, 0.36862, 0.00000], -[57, 0.76000, 0.50800, 0.00000], -[58, 0.90000, 0.36365, 0.00000], -[59, 0.75500, 0.50800, 0.00000], -[60, 0.90000, 0.35868, 0.00000], -[61, 0.75000, 0.50800, 0.00000], -[62, 0.90000, 0.35370, 0.00000], -[63, 0.74500, 0.50800, 0.00000], -[64, 0.90000, 0.34873, 0.00000], -[65, 0.74000, 0.50800, 0.00000], -[66, 0.90000, 0.34376, 0.00000], -[67, 0.73500, 0.50800, 0.00000], -[68, 0.90000, 0.33878, 0.00000], -[69, 0.73000, 0.50800, 0.00000], -[70, 0.90000, 0.33381, 0.00000], -[71, 0.72500, 0.50800, 0.00000], -[72, 0.90000, 0.32884, 0.00000], -[73, 0.72000, 0.50800, 0.00000], -[74, 0.90000, 0.32386, 0.00000], -[75, 0.71500, 0.50800, 0.00000], -[76, 0.90000, 0.31889, 0.00000], -[77, 0.71000, 0.50800, 0.00000], -[78, 0.90000, 0.31392, 0.00000], -[79, 0.70500, 0.50800, 0.00000], -[80, 0.90000, 0.30895, 0.00000], -[81, 0.70000, 0.50800, 0.00000], -[82, 0.90000, 0.30397, 0.00000], -[83, 0.69500, 0.50800, 0.00000], -[84, 0.90000, 0.29900, 0.00000], -[85, 0.69000, 0.50800, 0.00000], -[86, 0.90000, 0.29398, 0.00000], -[87, 0.68500, 0.50800, 0.00000], -[88, 0.90000, 0.28895, 0.00000], -[89, 0.68000, 0.50800, 0.00000], -[90, 0.90000, 0.28393, 0.00000], -[91, 0.67500, 0.50800, 0.00000], -[92, 0.90000, 0.27890, 0.00000], -[93, 0.67000, 0.50800, 0.00000], -[94, 0.90000, 0.27388, 0.00000], -[95, 0.66500, 0.50800, 0.00000], -[96, 0.90000, 0.26885, 0.00000], -[97, 0.66000, 0.50800, 0.00000], -[98, 0.90000, 0.26383, 0.00000], -[99, 0.65500, 0.50800, 0.00000], -[100, 0.90000, 0.25880, 0.00000], -[101, 0.65000, 0.50800, 0.00000], -[102, 0.90000, 0.25378, 0.00000], -[103, 0.64500, 0.50800, 0.00000], -[104, 0.90000, 0.24876, 0.00000], -[105, 0.64000, 0.50800, 0.00000], -[106, 0.90000, 0.24373, 0.00000], -[107, 0.63500, 0.50800, 0.00000], -[108, 0.90000, 0.23871, 0.00000], -[109, 0.63000, 0.50800, 0.00000], -[110, 0.90000, 0.23368, 0.00000], -[111, 0.62500, 0.50800, 0.00000], -[112, 0.90000, 0.22866, 0.00000], -[113, 0.62000, 0.50800, 0.00000], -[114, 0.90000, 0.22363, 0.00000], -[115, 0.61500, 0.50800, 0.00000], -[116, 0.90000, 0.21861, 0.00000], -[117, 0.61000, 0.50800, 0.00000], -[118, 0.90000, 0.21359, 0.00000], -[119, 0.60500, 0.50800, 0.00000], -[120, 0.90000, 0.20856, 0.00000], -[121, 0.60000, 0.50800, 0.00000], -[122, 0.90000, 0.20354, 0.00000], -[123, 0.59500, 0.50800, 0.00000], -[124, 0.90000, 0.19851, 0.00000], -[125, 0.59000, 0.50800, 0.00000], -[126, 0.90000, 0.19349, 0.00000], -[127, 0.58500, 0.50800, 0.00000], -[128, 0.90000, 0.18846, 0.00000], -[129, 0.58000, 0.50800, 0.00000], -[130, 0.90000, 0.18344, 0.00000], -[131, 0.57500, 0.50800, 0.00000], -[132, 0.90000, 0.17841, 0.00000], -[133, 0.57000, 0.50800, 0.00000], -[134, 0.90000, 0.17339, 0.00000], -[135, 0.56500, 0.50800, 0.00000], -[136, 0.90000, 0.16837, 0.00000], -[137, 0.56000, 0.50800, 0.00000], -[138, 0.90000, 0.16334, 0.00000], -[139, 0.55500, 0.50800, 0.00000], -[140, 0.90000, 0.15832, 0.00000], -[141, 0.55000, 0.50800, 0.00000], -[142, 0.90000, 0.15329, 0.00000], -[143, 0.54500, 0.50800, 0.00000], -[144, 0.90000, 0.14827, 0.00000], -[145, 0.54000, 0.50800, 0.00000], -[146, 0.90000, 0.14324, 0.00000], -[147, 0.53500, 0.50800, 0.00000], -[148, 0.90000, 0.13822, 0.00000], -[149, 0.53000, 0.50800, 0.00000], -[150, 0.90000, 0.13320, 0.00000], -[151, 0.52500, 0.50800, 0.00000], -[152, 0.90000, 0.12817, 0.00000], -[153, 0.52000, 0.50800, 0.00000], -[154, 0.90000, 0.12315, 0.00000], -[155, 0.51500, 0.50800, 0.00000], -[156, 0.90000, 0.11812, 0.00000], -[157, 0.51000, 0.50800, 0.00000], -[158, 0.90000, 0.11310, 0.00000], -[159, 0.50500, 0.50800, 0.00000], -[160, 0.90000, 0.10807, 0.00000], -[161, 0.50000, 0.50800, 0.00000], -[162, 0.90000, 0.10305, 0.00000], -[163, 0.49500, 0.50800, 0.00000], -[164, 0.90000, 0.09802, 0.00000], -[165, 0.49000, 0.50800, 0.00000], -[166, 0.48500, 0.50800, 0.00000], -[167, 0.90000, 0.09300, 0.00000], -[168, 0.89500, 0.09300, 0.00000], -[169, 0.89000, 0.09300, 0.00000], -[170, 0.88500, 0.09300, 0.00000], -[171, 0.88000, 0.09300, 0.00000], -[172, 0.87500, 0.09300, 0.00000], -[173, 0.87000, 0.09300, 0.00000], -[174, 0.86500, 0.09300, 0.00000], -[175, 0.86000, 0.09300, 0.00000], -[176, 0.85500, 0.09300, 0.00000], -[177, 0.85000, 0.09300, 0.00000], -[178, 0.84500, 0.09300, 0.00000], -[179, 0.84000, 0.09300, 0.00000], -[180, 0.89144, 0.08828, 0.00000], -[181, 0.90000, 0.08811, 0.00000], -[182, 0.88286, 0.08845, 0.00000], -[183, 0.48000, 0.50800, 0.00000], -[184, 0.83500, 0.09300, 0.00000], -[185, 0.87461, 0.08839, 0.00000], -[186, 0.86583, 0.08861, 0.00000], -[187, 0.83000, 0.09300, 0.00000], -[188, 0.88723, 0.08720, 0.00000], -[189, 0.85744, 0.08890, 0.00000], -[190, 0.82500, 0.09300, 0.00000], -[191, 0.85250, 0.08874, 0.00000], -[192, 0.87886, 0.08629, 0.00000], -[193, 0.89567, 0.08566, 0.00000], -[194, 0.84803, 0.08877, 0.00000], -[195, 0.82000, 0.09300, 0.00000], -[196, 0.87017, 0.08616, 0.00000], -[197, 0.86134, 0.08656, 0.00000], -[198, 0.83986, 0.08872, 0.00000], -[199, 0.81500, 0.09300, 0.00000], -[200, 0.81000, 0.09300, 0.00000], -[201, 0.89137, 0.08331, 0.00000], -[202, 0.90000, 0.08321, 0.00000], -[203, 0.88288, 0.08350, 0.00000], -[204, 0.47500, 0.50800, 0.00000], -[205, 0.87422, 0.08344, 0.00000], -[206, 0.82608, 0.08875, 0.00000], -[207, 0.80500, 0.09300, 0.00000], -[208, 0.86590, 0.08362, 0.00000], -[209, 0.83085, 0.08766, 0.00000], -[210, 0.85730, 0.08391, 0.00000], -[211, 0.84392, 0.08522, 0.00000], -[212, 0.80000, 0.09300, 0.00000], -[213, 0.84873, 0.08389, 0.00000], -[214, 0.83552, 0.08568, 0.00000], -[215, 0.89567, 0.08076, 0.00000], -[216, 0.88706, 0.08087, 0.00000], -[217, 0.81750, 0.08867, 0.00000], -[218, 0.87857, 0.08098, 0.00000], -[219, 0.87028, 0.08128, 0.00000], -[220, 0.79500, 0.09300, 0.00000], -[221, 0.86156, 0.08130, 0.00000], -[222, 0.82160, 0.08632, 0.00000], -[223, 0.81295, 0.08800, 0.00000], -[224, 0.85302, 0.08132, 0.00000], -[225, 0.79000, 0.09300, 0.00000], -[226, 0.83980, 0.08287, 0.00000], -[227, 0.80750, 0.08867, 0.00000], -[228, 0.90000, 0.07832, 0.00000], -[229, 0.89134, 0.07832, 0.00000], -[230, 0.88293, 0.07856, 0.00000], -[231, 0.47000, 0.50800, 0.00000], -[232, 0.84429, 0.08133, 0.00000], -[233, 0.87428, 0.07843, 0.00000], -[234, 0.86588, 0.07896, 0.00000], -[235, 0.82696, 0.08383, 0.00000], -[236, 0.80250, 0.08867, 0.00000], -[237, 0.78500, 0.09300, 0.00000], -[238, 0.83166, 0.08214, 0.00000], -[239, 0.85728, 0.07873, 0.00000], -[240, 0.79750, 0.08867, 0.00000], -[241, 0.78000, 0.09300, 0.00000], -[242, 0.89567, 0.07587, 0.00000], -[243, 0.84865, 0.07889, 0.00000], -[244, 0.88703, 0.07589, 0.00000], -[245, 0.87865, 0.07602, 0.00000], -[246, 0.87014, 0.07637, 0.00000], -[247, 0.79250, 0.08867, 0.00000], -[248, 0.83596, 0.07969, 0.00000], -[249, 0.81678, 0.08298, 0.00000], -[250, 0.86166, 0.07633, 0.00000], -[251, 0.77500, 0.09300, 0.00000], -[252, 0.84065, 0.07800, 0.00000], -[253, 0.78750, 0.08867, 0.00000], -[254, 0.85295, 0.07634, 0.00000], -[255, 0.82226, 0.08067, 0.00000], -[256, 0.89137, 0.07352, 0.00000], -[257, 0.90000, 0.07342, 0.00000], -[258, 0.82743, 0.07950, 0.00000], -[259, 0.88303, 0.07367, 0.00000], -[260, 0.77000, 0.09300, 0.00000], -[261, 0.46500, 0.50800, 0.00000], -[262, 0.87431, 0.07368, 0.00000], -[263, 0.80485, 0.08330, 0.00000], -[264, 0.84436, 0.07634, 0.00000], -[265, 0.80000, 0.08434, 0.00000], -[266, 0.86574, 0.07401, 0.00000], -[267, 0.78250, 0.08867, 0.00000], -[268, 0.81091, 0.08165, 0.00000], -[269, 0.85728, 0.07394, 0.00000], -[270, 0.83185, 0.07719, 0.00000], -[271, 0.76500, 0.09300, 0.00000], -[272, 0.79500, 0.08434, 0.00000], -[273, 0.77750, 0.08867, 0.00000], -[274, 0.89567, 0.07097, 0.00000], -[275, 0.84873, 0.07390, 0.00000], -[276, 0.83636, 0.07554, 0.00000], -[277, 0.87864, 0.07132, 0.00000], -[278, 0.88713, 0.07090, 0.00000], -[279, 0.87001, 0.07141, 0.00000], -[280, 0.79000, 0.08434, 0.00000], -[281, 0.76000, 0.09300, 0.00000], -[282, 0.81454, 0.07835, 0.00000], -[283, 0.77250, 0.08867, 0.00000], -[284, 0.86156, 0.07140, 0.00000], -[285, 0.81856, 0.07732, 0.00000], -[286, 0.84073, 0.07322, 0.00000], -[287, 0.82330, 0.07579, 0.00000], -[288, 0.78500, 0.08434, 0.00000], -[289, 0.80689, 0.07889, 0.00000], -[290, 0.85302, 0.07135, 0.00000], -[291, 0.90000, 0.06853, 0.00000], -[292, 0.89134, 0.06853, 0.00000], -[293, 0.75500, 0.09300, 0.00000], -[294, 0.88289, 0.06873, 0.00000], -[295, 0.76750, 0.08867, 0.00000], -[296, 0.82795, 0.07408, 0.00000], -[297, 0.79676, 0.08039, 0.00000], -[298, 0.87436, 0.06884, 0.00000], -[299, 0.46000, 0.50800, 0.00000], -[300, 0.84443, 0.07134, 0.00000], -[301, 0.78000, 0.08434, 0.00000], -[302, 0.86567, 0.06891, 0.00000], -[303, 0.81080, 0.07665, 0.00000], -[304, 0.83261, 0.07230, 0.00000], -[305, 0.85714, 0.06909, 0.00000], -[306, 0.75000, 0.09300, 0.00000], -[307, 0.79250, 0.08001, 0.00000], -[308, 0.76250, 0.08867, 0.00000], -[309, 0.83730, 0.07113, 0.00000], -[310, 0.80131, 0.07757, 0.00000], -[311, 0.77500, 0.08434, 0.00000], -[312, 0.89567, 0.06608, 0.00000], -[313, 0.88713, 0.06615, 0.00000], -[314, 0.84868, 0.06891, 0.00000], -[315, 0.87858, 0.06621, 0.00000], -[316, 0.81490, 0.07392, 0.00000], -[317, 0.78750, 0.08001, 0.00000], -[318, 0.87000, 0.06641, 0.00000], -[319, 0.81968, 0.07246, 0.00000], -[320, 0.75750, 0.08867, 0.00000], -[321, 0.74500, 0.09300, 0.00000], -[322, 0.77000, 0.08434, 0.00000], -[323, 0.86138, 0.06645, 0.00000], -[324, 0.84062, 0.06842, 0.00000], -[325, 0.82407, 0.07093, 0.00000], -[326, 0.80644, 0.07425, 0.00000], -[327, 0.78250, 0.08001, 0.00000], -[328, 0.85300, 0.06642, 0.00000], -[329, 0.90000, 0.06363, 0.00000], -[330, 0.75250, 0.08867, 0.00000], -[331, 0.89137, 0.06353, 0.00000], -[332, 0.88293, 0.06377, 0.00000], -[333, 0.76500, 0.08434, 0.00000], -[334, 0.74000, 0.09300, 0.00000], -[335, 0.79500, 0.07568, 0.00000], -[336, 0.87426, 0.06385, 0.00000], -[337, 0.45500, 0.50800, 0.00000], -[338, 0.84435, 0.06641, 0.00000], -[339, 0.77750, 0.08001, 0.00000], -[340, 0.81074, 0.07173, 0.00000], -[341, 0.86568, 0.06391, 0.00000], -[342, 0.83540, 0.06713, 0.00000], -[343, 0.82903, 0.06788, 0.00000], -[344, 0.81521, 0.07024, 0.00000], -[345, 0.85741, 0.06411, 0.00000], -[346, 0.79000, 0.07568, 0.00000], -[347, 0.76000, 0.08434, 0.00000], -[348, 0.74750, 0.08867, 0.00000], -[349, 0.77250, 0.08001, 0.00000], -[350, 0.73500, 0.09300, 0.00000], -[351, 0.89567, 0.06118, 0.00000], -[352, 0.88703, 0.06117, 0.00000], -[353, 0.84868, 0.06391, 0.00000], -[354, 0.87858, 0.06134, 0.00000], -[355, 0.78500, 0.07568, 0.00000], -[356, 0.80250, 0.07135, 0.00000], -[357, 0.87001, 0.06144, 0.00000], -[358, 0.75500, 0.08434, 0.00000], -[359, 0.81935, 0.06748, 0.00000], -[360, 0.74250, 0.08867, 0.00000], -[361, 0.76750, 0.08001, 0.00000], -[362, 0.86159, 0.06155, 0.00000], -[363, 0.84043, 0.06360, 0.00000], -[364, 0.73000, 0.09300, 0.00000], -[365, 0.79750, 0.07135, 0.00000], -[366, 0.78000, 0.07568, 0.00000], -[367, 0.85320, 0.06143, 0.00000], -[368, 0.81165, 0.06776, 0.00000], -[369, 0.83206, 0.06409, 0.00000], -[370, 0.80691, 0.06853, 0.00000], -[371, 0.90000, 0.05874, 0.00000], -[372, 0.89134, 0.05874, 0.00000], -[373, 0.75000, 0.08434, 0.00000], -[374, 0.76250, 0.08001, 0.00000], -[375, 0.88281, 0.05879, 0.00000], -[376, 0.79250, 0.07135, 0.00000], -[377, 0.73750, 0.08867, 0.00000], -[378, 0.82353, 0.06474, 0.00000], -[379, 0.87428, 0.05886, 0.00000], -[380, 0.84491, 0.06149, 0.00000], -[381, 0.45000, 0.50800, 0.00000], -[382, 0.77500, 0.07568, 0.00000], -[383, 0.86549, 0.05903, 0.00000], -[384, 0.72500, 0.09300, 0.00000], -[385, 0.81493, 0.06526, 0.00000], -[386, 0.85724, 0.05914, 0.00000], -[387, 0.78750, 0.07135, 0.00000], -[388, 0.75750, 0.08001, 0.00000], -[389, 0.74500, 0.08434, 0.00000], -[390, 0.83606, 0.06119, 0.00000], -[391, 0.77000, 0.07568, 0.00000], -[392, 0.73250, 0.08867, 0.00000], -[393, 0.89567, 0.05629, 0.00000], -[394, 0.82758, 0.06189, 0.00000], -[395, 0.84841, 0.05898, 0.00000], -[396, 0.88706, 0.05618, 0.00000], -[397, 0.87845, 0.05638, 0.00000], -[398, 0.80000, 0.06702, 0.00000], -[399, 0.78250, 0.07135, 0.00000], -[400, 0.72000, 0.09300, 0.00000], -[401, 0.86994, 0.05645, 0.00000], -[402, 0.75250, 0.08001, 0.00000], -[403, 0.81908, 0.06249, 0.00000], -[404, 0.74000, 0.08434, 0.00000], -[405, 0.76500, 0.07568, 0.00000], -[406, 0.86121, 0.05645, 0.00000], -[407, 0.84082, 0.05863, 0.00000], -[408, 0.79500, 0.06702, 0.00000], -[409, 0.72750, 0.08867, 0.00000], -[410, 0.77750, 0.07135, 0.00000], -[411, 0.83175, 0.05916, 0.00000], -[412, 0.85271, 0.05643, 0.00000], -[413, 0.80940, 0.06299, 0.00000], -[414, 0.90000, 0.05384, 0.00000], -[415, 0.89137, 0.05374, 0.00000], -[416, 0.74750, 0.08001, 0.00000], -[417, 0.71500, 0.09300, 0.00000], -[418, 0.76000, 0.07568, 0.00000], -[419, 0.79000, 0.06702, 0.00000], -[420, 0.88272, 0.05380, 0.00000], -[421, 0.73500, 0.08434, 0.00000], -[422, 0.82328, 0.05980, 0.00000], -[423, 0.87408, 0.05389, 0.00000], -[424, 0.77250, 0.07135, 0.00000], -[425, 0.44500, 0.50800, 0.00000], -[426, 0.84400, 0.05639, 0.00000], -[427, 0.86557, 0.05403, 0.00000], -[428, 0.83609, 0.05719, 0.00000], -[429, 0.72250, 0.08867, 0.00000], -[430, 0.78500, 0.06702, 0.00000], -[431, 0.81462, 0.06028, 0.00000], -[432, 0.80250, 0.06269, 0.00000], -[433, 0.75500, 0.07568, 0.00000], -[434, 0.74250, 0.08001, 0.00000], -[435, 0.85696, 0.05382, 0.00000], -[436, 0.76750, 0.07135, 0.00000], -[437, 0.71000, 0.09300, 0.00000], -[438, 0.73000, 0.08434, 0.00000], -[439, 0.89567, 0.05139, 0.00000], -[440, 0.88704, 0.05139, 0.00000], -[441, 0.82729, 0.05691, 0.00000], -[442, 0.84838, 0.05398, 0.00000], -[443, 0.79750, 0.06269, 0.00000], -[444, 0.78000, 0.06702, 0.00000], -[445, 0.87839, 0.05139, 0.00000], -[446, 0.71750, 0.08867, 0.00000], -[447, 0.86983, 0.05145, 0.00000], -[448, 0.81881, 0.05759, 0.00000], -[449, 0.76250, 0.07135, 0.00000], -[450, 0.73750, 0.08001, 0.00000], -[451, 0.83984, 0.05395, 0.00000], -[452, 0.79250, 0.06269, 0.00000], -[453, 0.74954, 0.07525, 0.00000], -[454, 0.86136, 0.05147, 0.00000], -[455, 0.77500, 0.06702, 0.00000], -[456, 0.72500, 0.08434, 0.00000], -[457, 0.70500, 0.09300, 0.00000], -[458, 0.83213, 0.05423, 0.00000], -[459, 0.81019, 0.05803, 0.00000], -[460, 0.85261, 0.05144, 0.00000], -[461, 0.89137, 0.04905, 0.00000], -[462, 0.90000, 0.04895, 0.00000], -[463, 0.78750, 0.06269, 0.00000], -[464, 0.75750, 0.07135, 0.00000], -[465, 0.88272, 0.04899, 0.00000], -[466, 0.73250, 0.08001, 0.00000], -[467, 0.82298, 0.05486, 0.00000], -[468, 0.77000, 0.06702, 0.00000], -[469, 0.87414, 0.04891, 0.00000], -[470, 0.44000, 0.50800, 0.00000], -[471, 0.84412, 0.05139, 0.00000], -[472, 0.86543, 0.04911, 0.00000], -[473, 0.74416, 0.07498, 0.00000], -[474, 0.72000, 0.08434, 0.00000], -[475, 0.71149, 0.08784, 0.00000], -[476, 0.78250, 0.06269, 0.00000], -[477, 0.80567, 0.05719, 0.00000], -[478, 0.80000, 0.05836, 0.00000], -[479, 0.70000, 0.09300, 0.00000], -[480, 0.81438, 0.05529, 0.00000], -[481, 0.82734, 0.05294, 0.00000], -[482, 0.85700, 0.04907, 0.00000], -[483, 0.83543, 0.05137, 0.00000], -[484, 0.76500, 0.06702, 0.00000], -[485, 0.72750, 0.08001, 0.00000], -[486, 0.89567, 0.04650, 0.00000], -[487, 0.88706, 0.04661, 0.00000], -[488, 0.79500, 0.05836, 0.00000], -[489, 0.75184, 0.07061, 0.00000], -[490, 0.84851, 0.04905, 0.00000], -[491, 0.77750, 0.06269, 0.00000], -[492, 0.87845, 0.04641, 0.00000], -[493, 0.73890, 0.07476, 0.00000], -[494, 0.86992, 0.04654, 0.00000], -[495, 0.81853, 0.05260, 0.00000], -[496, 0.76000, 0.06702, 0.00000], -[497, 0.69500, 0.09300, 0.00000], -[498, 0.83981, 0.04897, 0.00000], -[499, 0.70608, 0.08750, 0.00000], -[500, 0.79012, 0.05813, 0.00000], -[501, 0.86118, 0.04649, 0.00000], -[502, 0.71396, 0.08348, 0.00000], -[503, 0.83094, 0.04953, 0.00000], -[504, 0.80991, 0.05304, 0.00000], -[505, 0.90000, 0.04405, 0.00000], -[506, 0.85277, 0.04645, 0.00000], -[507, 0.74622, 0.07024, 0.00000], -[508, 0.89134, 0.04405, 0.00000], -[509, 0.78500, 0.05836, 0.00000], -[510, 0.73373, 0.07463, 0.00000], -[511, 0.88281, 0.04400, 0.00000], -[512, 0.72163, 0.07929, 0.00000], -[513, 0.76711, 0.06291, 0.00000], -[514, 0.82272, 0.04987, 0.00000], -[515, 0.84416, 0.04661, 0.00000], -[516, 0.87416, 0.04392, 0.00000], -[517, 0.77107, 0.06144, 0.00000], -[518, 0.43500, 0.50800, 0.00000], -[519, 0.70118, 0.08758, 0.00000], -[520, 0.69000, 0.09300, 0.00000], -[521, 0.86555, 0.04412, 0.00000], -[522, 0.79779, 0.05421, 0.00000], -[523, 0.80170, 0.05331, 0.00000], -[524, 0.78000, 0.05836, 0.00000], -[525, 0.81410, 0.05031, 0.00000], -[526, 0.80599, 0.05189, 0.00000], -[527, 0.85718, 0.04416, 0.00000], -[528, 0.72871, 0.07461, 0.00000], -[529, 0.75412, 0.06538, 0.00000], -[530, 0.83553, 0.04638, 0.00000], -[531, 0.74069, 0.06984, 0.00000], -[532, 0.77526, 0.05868, 0.00000], -[533, 0.89567, 0.04161, 0.00000], -[534, 0.88703, 0.04162, 0.00000], -[535, 0.82613, 0.04733, 0.00000], -[536, 0.71625, 0.07898, 0.00000], -[537, 0.84846, 0.04407, 0.00000], -[538, 0.87852, 0.04156, 0.00000], -[539, 0.70750, 0.08227, 0.00000], -[540, 0.68500, 0.09300, 0.00000], -[541, 0.86984, 0.04156, 0.00000], -[542, 0.69600, 0.08743, 0.00000], -[543, 0.81830, 0.04761, 0.00000], -[544, 0.79325, 0.05265, 0.00000], -[545, 0.78750, 0.05403, 0.00000], -[546, 0.83992, 0.04398, 0.00000], -[547, 0.74819, 0.06537, 0.00000], -[548, 0.86141, 0.04153, 0.00000], -[549, 0.75776, 0.06204, 0.00000], -[550, 0.72350, 0.07444, 0.00000], -[551, 0.76246, 0.06054, 0.00000], -[552, 0.82980, 0.04466, 0.00000], -[553, 0.85281, 0.04176, 0.00000], -[554, 0.73500, 0.06928, 0.00000], -[555, 0.76702, 0.05850, 0.00000], -[556, 0.89137, 0.03926, 0.00000], -[557, 0.90000, 0.03916, 0.00000], -[558, 0.78250, 0.05403, 0.00000], -[559, 0.88289, 0.03927, 0.00000], -[560, 0.70250, 0.08227, 0.00000], -[561, 0.77159, 0.05647, 0.00000], -[562, 0.87418, 0.03922, 0.00000], -[563, 0.77691, 0.05479, 0.00000], -[564, 0.71045, 0.07832, 0.00000], -[565, 0.69100, 0.08743, 0.00000], -[566, 0.68000, 0.09300, 0.00000], -[567, 0.80840, 0.04719, 0.00000], -[568, 0.84420, 0.04145, 0.00000], -[569, 0.79846, 0.04920, 0.00000], -[570, 0.43000, 0.50800, 0.00000], -[571, 0.82191, 0.04433, 0.00000], -[572, 0.74250, 0.06495, 0.00000], -[573, 0.80294, 0.04785, 0.00000], -[574, 0.86563, 0.03889, 0.00000], -[575, 0.71815, 0.07415, 0.00000], -[576, 0.73000, 0.06928, 0.00000], -[577, 0.85709, 0.03918, 0.00000], -[578, 0.74996, 0.06151, 0.00000], -[579, 0.83565, 0.04138, 0.00000], -[580, 0.89567, 0.03671, 0.00000], -[581, 0.69750, 0.08227, 0.00000], -[582, 0.88713, 0.03664, 0.00000], -[583, 0.75384, 0.05965, 0.00000], -[584, 0.84860, 0.03909, 0.00000], -[585, 0.87847, 0.03667, 0.00000], -[586, 0.68600, 0.08743, 0.00000], -[587, 0.78513, 0.05029, 0.00000], -[588, 0.73750, 0.06495, 0.00000], -[589, 0.81311, 0.04401, 0.00000], -[590, 0.67500, 0.09300, 0.00000], -[591, 0.75841, 0.05761, 0.00000], -[592, 0.70500, 0.07794, 0.00000], -[593, 0.82605, 0.04155, 0.00000], -[594, 0.87007, 0.03663, 0.00000], -[595, 0.72500, 0.06928, 0.00000], -[596, 0.71289, 0.07394, 0.00000], -[597, 0.78985, 0.04831, 0.00000], -[598, 0.76297, 0.05557, 0.00000], -[599, 0.83967, 0.03890, 0.00000], -[600, 0.86132, 0.03655, 0.00000], -[601, 0.76754, 0.05353, 0.00000], -[602, 0.74500, 0.06062, 0.00000], -[603, 0.85302, 0.03677, 0.00000], -[604, 0.69250, 0.08227, 0.00000], -[605, 0.79441, 0.04627, 0.00000], -[606, 0.73250, 0.06495, 0.00000], -[607, 0.90000, 0.03426, 0.00000], -[608, 0.89134, 0.03426, 0.00000], -[609, 0.88277, 0.03428, 0.00000], -[610, 0.77210, 0.05149, 0.00000], -[611, 0.83084, 0.03894, 0.00000], -[612, 0.68100, 0.08743, 0.00000], -[613, 0.72000, 0.06928, 0.00000], -[614, 0.70000, 0.07794, 0.00000], -[615, 0.67000, 0.09300, 0.00000], -[616, 0.81686, 0.04086, 0.00000], -[617, 0.87413, 0.03423, 0.00000], -[618, 0.79902, 0.04421, 0.00000], -[619, 0.84435, 0.03646, 0.00000], -[620, 0.77932, 0.04868, 0.00000], -[621, 0.86567, 0.03429, 0.00000], -[622, 0.42500, 0.50800, 0.00000], -[623, 0.74000, 0.06062, 0.00000], -[624, 0.70750, 0.07361, 0.00000], -[625, 0.80373, 0.04271, 0.00000], -[626, 0.72750, 0.06495, 0.00000], -[627, 0.85699, 0.03420, 0.00000], -[628, 0.82140, 0.03876, 0.00000], -[629, 0.68750, 0.08227, 0.00000], -[630, 0.71500, 0.06928, 0.00000], -[631, 0.75436, 0.05468, 0.00000], -[632, 0.74867, 0.05654, 0.00000], -[633, 0.83551, 0.03623, 0.00000], -[634, 0.89567, 0.03182, 0.00000], -[635, 0.80843, 0.04060, 0.00000], -[636, 0.88706, 0.03181, 0.00000], -[637, 0.69500, 0.07794, 0.00000], -[638, 0.67600, 0.08743, 0.00000], -[639, 0.78580, 0.04537, 0.00000], -[640, 0.84840, 0.03413, 0.00000], -[641, 0.75892, 0.05264, 0.00000], -[642, 0.87837, 0.03169, 0.00000], -[643, 0.73500, 0.06062, 0.00000], -[644, 0.66500, 0.09300, 0.00000], -[645, 0.70250, 0.07361, 0.00000], -[646, 0.72250, 0.06495, 0.00000], -[647, 0.86986, 0.03165, 0.00000], -[648, 0.76349, 0.05060, 0.00000], -[649, 0.79036, 0.04333, 0.00000], -[650, 0.82685, 0.03614, 0.00000], -[651, 0.86132, 0.03185, 0.00000], -[652, 0.83972, 0.03395, 0.00000], -[653, 0.76805, 0.04856, 0.00000], -[654, 0.81276, 0.03799, 0.00000], -[655, 0.68250, 0.08227, 0.00000], -[656, 0.71000, 0.06928, 0.00000], -[657, 0.74250, 0.05629, 0.00000], -[658, 0.79496, 0.04129, 0.00000], -[659, 0.89144, 0.02955, 0.00000], -[660, 0.77317, 0.04656, 0.00000], -[661, 0.73000, 0.06062, 0.00000], -[662, 0.69000, 0.07794, 0.00000], -[663, 0.90000, 0.02937, 0.00000], -[664, 0.85270, 0.03163, 0.00000], -[665, 0.67100, 0.08743, 0.00000], -[666, 0.88275, 0.02929, 0.00000], -[667, 0.71750, 0.06495, 0.00000], -[668, 0.69750, 0.07361, 0.00000], -[669, 0.83121, 0.03369, 0.00000], -[670, 0.81731, 0.03588, 0.00000], -[671, 0.66000, 0.09300, 0.00000], -[672, 0.87425, 0.02928, 0.00000], -[673, 0.79951, 0.03923, 0.00000], -[674, 0.77718, 0.04448, 0.00000], -[675, 0.84410, 0.03160, 0.00000], -[676, 0.86562, 0.02933, 0.00000], -[677, 0.42000, 0.50800, 0.00000], -[678, 0.73750, 0.05629, 0.00000], -[679, 0.75000, 0.05196, 0.00000], -[680, 0.70500, 0.06928, 0.00000], -[681, 0.78143, 0.04265, 0.00000], -[682, 0.67750, 0.08227, 0.00000], -[683, 0.72500, 0.06062, 0.00000], -[684, 0.80407, 0.03718, 0.00000], -[685, 0.85708, 0.02922, 0.00000], -[686, 0.68500, 0.07794, 0.00000], -[687, 0.82244, 0.03326, 0.00000], -[688, 0.71250, 0.06495, 0.00000], -[689, 0.89567, 0.02692, 0.00000], -[690, 0.83554, 0.03123, 0.00000], -[691, 0.78631, 0.04040, 0.00000], -[692, 0.66600, 0.08743, 0.00000], -[693, 0.75944, 0.04766, 0.00000], -[694, 0.88727, 0.02683, 0.00000], -[695, 0.69250, 0.07361, 0.00000], -[696, 0.84846, 0.02916, 0.00000], -[697, 0.80868, 0.03510, 0.00000], -[698, 0.74500, 0.05196, 0.00000], -[699, 0.75376, 0.04904, 0.00000], -[700, 0.73250, 0.05629, 0.00000], -[701, 0.87851, 0.02670, 0.00000], -[702, 0.65500, 0.09300, 0.00000], -[703, 0.76400, 0.04562, 0.00000], -[704, 0.86990, 0.02683, 0.00000], -[705, 0.79090, 0.03837, 0.00000], -[706, 0.70000, 0.06928, 0.00000], -[707, 0.72000, 0.06062, 0.00000], -[708, 0.82693, 0.03110, 0.00000], -[709, 0.76857, 0.04359, 0.00000], -[710, 0.67250, 0.08227, 0.00000], -[711, 0.83999, 0.02899, 0.00000], -[712, 0.86137, 0.02673, 0.00000], -[713, 0.81322, 0.03301, 0.00000], -[714, 0.70750, 0.06495, 0.00000], -[715, 0.68000, 0.07794, 0.00000], -[716, 0.79546, 0.03632, 0.00000], -[717, 0.74000, 0.05196, 0.00000], -[718, 0.77314, 0.04155, 0.00000], -[719, 0.89137, 0.02457, 0.00000], -[720, 0.72750, 0.05629, 0.00000], -[721, 0.90000, 0.02447, 0.00000], -[722, 0.68750, 0.07361, 0.00000], -[723, 0.85271, 0.02669, 0.00000], -[724, 0.66100, 0.08743, 0.00000], -[725, 0.88292, 0.02440, 0.00000], -[726, 0.71500, 0.06062, 0.00000], -[727, 0.81775, 0.03090, 0.00000], -[728, 0.80002, 0.03426, 0.00000], -[729, 0.83132, 0.02871, 0.00000], -[730, 0.77770, 0.03951, 0.00000], -[731, 0.69500, 0.06928, 0.00000], -[732, 0.87421, 0.02430, 0.00000], -[733, 0.65000, 0.09300, 0.00000], -[734, 0.84428, 0.02645, 0.00000], -[735, 0.86577, 0.02438, 0.00000], -[736, 0.74750, 0.04763, 0.00000], -[737, 0.73500, 0.05196, 0.00000], -[738, 0.41500, 0.50800, 0.00000], -[739, 0.78227, 0.03747, 0.00000], -[740, 0.70250, 0.06495, 0.00000], -[741, 0.66750, 0.08227, 0.00000], -[742, 0.80455, 0.03221, 0.00000], -[743, 0.75539, 0.04473, 0.00000], -[744, 0.72250, 0.05629, 0.00000], -[745, 0.67500, 0.07794, 0.00000], -[746, 0.83576, 0.02660, 0.00000], -[747, 0.85705, 0.02423, 0.00000], -[748, 0.68250, 0.07361, 0.00000], -[749, 0.82285, 0.02829, 0.00000], -[750, 0.75996, 0.04269, 0.00000], -[751, 0.78683, 0.03543, 0.00000], -[752, 0.89567, 0.02203, 0.00000], -[753, 0.71000, 0.06062, 0.00000], -[754, 0.65600, 0.08743, 0.00000], -[755, 0.88724, 0.02191, 0.00000], -[756, 0.69000, 0.06928, 0.00000], -[757, 0.80914, 0.03012, 0.00000], -[758, 0.84875, 0.02425, 0.00000], -[759, 0.87856, 0.02201, 0.00000], -[760, 0.74250, 0.04763, 0.00000], -[761, 0.76452, 0.04065, 0.00000], -[762, 0.73000, 0.05196, 0.00000], -[763, 0.79139, 0.03339, 0.00000], -[764, 0.87005, 0.02184, 0.00000], -[765, 0.64500, 0.09300, 0.00000], -[766, 0.69750, 0.06495, 0.00000], -[767, 0.82739, 0.02630, 0.00000], -[768, 0.71750, 0.05629, 0.00000], -[769, 0.76909, 0.03861, 0.00000], -[770, 0.75072, 0.04398, 0.00000], -[771, 0.66250, 0.08227, 0.00000], -[772, 0.86145, 0.02187, 0.00000], -[773, 0.81366, 0.02803, 0.00000], -[774, 0.84001, 0.02401, 0.00000], -[775, 0.67000, 0.07794, 0.00000], -[776, 0.79596, 0.03135, 0.00000], -[777, 0.70500, 0.06062, 0.00000], -[778, 0.67750, 0.07361, 0.00000], -[779, 0.77365, 0.03657, 0.00000], -[780, 0.73750, 0.04763, 0.00000], -[781, 0.90000, 0.01958, 0.00000], -[782, 0.72500, 0.05196, 0.00000], -[783, 0.89134, 0.01958, 0.00000], -[784, 0.68500, 0.06928, 0.00000], -[785, 0.85279, 0.02170, 0.00000], -[786, 0.65100, 0.08743, 0.00000], -[787, 0.88286, 0.01951, 0.00000], -[788, 0.77822, 0.03453, 0.00000], -[789, 0.80050, 0.02929, 0.00000], -[790, 0.81819, 0.02592, 0.00000], -[791, 0.83168, 0.02374, 0.00000], -[792, 0.71250, 0.05629, 0.00000], -[793, 0.69250, 0.06495, 0.00000], -[794, 0.87437, 0.01932, 0.00000], -[795, 0.84440, 0.02178, 0.00000], -[796, 0.64000, 0.09300, 0.00000], -[797, 0.78278, 0.03249, 0.00000], -[798, 0.86580, 0.01941, 0.00000], -[799, 0.74500, 0.04330, 0.00000], -[800, 0.73250, 0.04763, 0.00000], -[801, 0.65750, 0.08227, 0.00000], -[802, 0.41000, 0.50800, 0.00000], -[803, 0.80506, 0.02724, 0.00000], -[804, 0.70000, 0.06062, 0.00000], -[805, 0.66500, 0.07794, 0.00000], -[806, 0.72000, 0.05196, 0.00000], -[807, 0.67250, 0.07361, 0.00000], -[808, 0.85720, 0.01943, 0.00000], -[809, 0.76047, 0.03772, 0.00000], -[810, 0.83570, 0.02162, 0.00000], -[811, 0.78735, 0.03045, 0.00000], -[812, 0.75405, 0.03953, 0.00000], -[813, 0.82339, 0.02333, 0.00000], -[814, 0.68000, 0.06928, 0.00000], -[815, 0.89567, 0.01713, 0.00000], -[816, 0.70750, 0.05629, 0.00000], -[817, 0.88715, 0.01698, 0.00000], -[818, 0.76504, 0.03568, 0.00000], -[819, 0.80958, 0.02515, 0.00000], -[820, 0.64600, 0.08743, 0.00000], -[821, 0.87850, 0.01711, 0.00000], -[822, 0.68750, 0.06495, 0.00000], -[823, 0.84871, 0.01925, 0.00000], -[824, 0.74000, 0.04330, 0.00000], -[825, 0.79191, 0.02841, 0.00000], -[826, 0.72750, 0.04763, 0.00000], -[827, 0.76960, 0.03364, 0.00000], -[828, 0.87004, 0.01685, 0.00000], -[829, 0.82734, 0.02131, 0.00000], -[830, 0.69500, 0.06062, 0.00000], -[831, 0.71500, 0.05196, 0.00000], -[832, 0.84005, 0.01931, 0.00000], -[833, 0.63500, 0.09300, 0.00000], -[834, 0.65250, 0.08227, 0.00000], -[835, 0.81409, 0.02306, 0.00000], -[836, 0.66000, 0.07794, 0.00000], -[837, 0.79648, 0.02638, 0.00000], -[838, 0.86149, 0.01688, 0.00000], -[839, 0.66750, 0.07361, 0.00000], -[840, 0.77417, 0.03160, 0.00000], -[841, 0.70250, 0.05629, 0.00000], -[842, 0.67500, 0.06928, 0.00000], -[843, 0.73500, 0.04330, 0.00000], -[844, 0.74750, 0.03897, 0.00000], -[845, 0.90000, 0.01468, 0.00000], -[846, 0.72250, 0.04763, 0.00000], -[847, 0.89137, 0.01459, 0.00000], -[848, 0.85301, 0.01672, 0.00000], -[849, 0.68250, 0.06495, 0.00000], -[850, 0.77873, 0.02956, 0.00000], -[851, 0.81866, 0.02104, 0.00000], -[852, 0.80102, 0.02431, 0.00000], -[853, 0.88279, 0.01457, 0.00000], -[854, 0.83167, 0.01885, 0.00000], -[855, 0.64100, 0.08743, 0.00000], -[856, 0.71000, 0.05196, 0.00000], -[857, 0.69000, 0.06062, 0.00000], -[858, 0.87438, 0.01440, 0.00000], -[859, 0.84437, 0.01679, 0.00000], -[860, 0.78330, 0.02752, 0.00000], -[861, 0.86584, 0.01445, 0.00000], -[862, 0.74250, 0.03897, 0.00000], -[863, 0.80558, 0.02229, 0.00000], -[864, 0.73000, 0.04330, 0.00000], -[865, 0.65500, 0.07794, 0.00000], -[866, 0.64750, 0.08227, 0.00000], -[867, 0.40500, 0.50800, 0.00000], -[868, 0.69750, 0.05629, 0.00000], -[869, 0.66250, 0.07361, 0.00000], -[870, 0.63000, 0.09300, 0.00000], -[871, 0.76099, 0.03274, 0.00000], -[872, 0.71750, 0.04763, 0.00000], -[873, 0.82303, 0.01880, 0.00000], -[874, 0.75582, 0.03413, 0.00000], -[875, 0.67000, 0.06928, 0.00000], -[876, 0.78786, 0.02548, 0.00000], -[877, 0.85716, 0.01444, 0.00000], -[878, 0.83585, 0.01664, 0.00000], -[879, 0.67750, 0.06495, 0.00000], -[880, 0.89567, 0.01224, 0.00000], -[881, 0.76555, 0.03070, 0.00000], -[882, 0.70500, 0.05196, 0.00000], -[883, 0.81013, 0.02021, 0.00000], -[884, 0.88708, 0.01204, 0.00000], -[885, 0.87882, 0.01214, 0.00000], -[886, 0.79243, 0.02345, 0.00000], -[887, 0.68500, 0.06062, 0.00000], -[888, 0.73750, 0.03897, 0.00000], -[889, 0.84868, 0.01425, 0.00000], -[890, 0.75000, 0.03464, 0.00000], -[891, 0.72500, 0.04330, 0.00000], -[892, 0.63600, 0.08743, 0.00000], -[893, 0.77012, 0.02867, 0.00000], -[894, 0.82737, 0.01633, 0.00000], -[895, 0.87009, 0.01185, 0.00000], -[896, 0.71250, 0.04763, 0.00000], -[897, 0.69250, 0.05629, 0.00000], -[898, 0.84027, 0.01432, 0.00000], -[899, 0.81464, 0.01809, 0.00000], -[900, 0.79700, 0.02142, 0.00000], -[901, 0.77468, 0.02663, 0.00000], -[902, 0.65000, 0.07794, 0.00000], -[903, 0.65750, 0.07361, 0.00000], -[904, 0.86149, 0.01199, 0.00000], -[905, 0.64250, 0.08227, 0.00000], -[906, 0.66500, 0.06928, 0.00000], -[907, 0.62500, 0.09300, 0.00000], -[908, 0.70000, 0.05196, 0.00000], -[909, 0.73250, 0.03897, 0.00000], -[910, 0.67250, 0.06495, 0.00000], -[911, 0.74500, 0.03464, 0.00000], -[912, 0.90000, 0.00979, 0.00000], -[913, 0.77925, 0.02459, 0.00000], -[914, 0.72000, 0.04330, 0.00000], -[915, 0.81923, 0.01616, 0.00000], -[916, 0.85300, 0.01178, 0.00000], -[917, 0.89144, 0.00961, 0.00000], -[918, 0.80154, 0.01934, 0.00000], -[919, 0.68000, 0.06062, 0.00000], -[920, 0.88273, 0.00957, 0.00000], -[921, 0.83173, 0.01392, 0.00000], -[922, 0.70750, 0.04763, 0.00000], -[923, 0.75694, 0.02981, 0.00000], -[924, 0.78382, 0.02255, 0.00000], -[925, 0.68750, 0.05629, 0.00000], -[926, 0.87464, 0.00941, 0.00000], -[927, 0.63100, 0.08743, 0.00000], -[928, 0.84434, 0.01179, 0.00000], -[929, 0.80605, 0.01731, 0.00000], -[930, 0.74000, 0.03464, 0.00000], -[931, 0.86580, 0.00947, 0.00000], -[932, 0.72750, 0.03897, 0.00000], -[933, 0.76151, 0.02777, 0.00000], -[934, 0.75250, 0.03031, 0.00000], -[935, 0.65250, 0.07361, 0.00000], -[936, 0.64500, 0.07794, 0.00000], -[937, 0.69500, 0.05196, 0.00000], -[938, 0.40000, 0.50800, 0.00000], -[939, 0.66000, 0.06928, 0.00000], -[940, 0.78839, 0.02051, 0.00000], -[941, 0.63750, 0.08227, 0.00000], -[942, 0.71500, 0.04330, 0.00000], -[943, 0.82329, 0.01358, 0.00000], -[944, 0.66750, 0.06495, 0.00000], -[945, 0.85720, 0.00944, 0.00000], -[946, 0.83618, 0.01167, 0.00000], -[947, 0.76607, 0.02573, 0.00000], -[948, 0.62000, 0.09300, 0.00000], -[949, 0.89567, 0.00734, 0.00000], -[950, 0.67500, 0.06062, 0.00000], -[951, 0.81060, 0.01524, 0.00000], -[952, 0.70250, 0.04763, 0.00000], -[953, 0.79295, 0.01848, 0.00000], -[954, 0.77064, 0.02369, 0.00000], -[955, 0.73500, 0.03464, 0.00000], -[956, 0.84867, 0.00931, 0.00000], -[957, 0.68250, 0.05629, 0.00000], -[958, 0.74750, 0.03031, 0.00000], -[959, 0.72250, 0.03897, 0.00000], -[960, 0.82783, 0.01167, 0.00000], -[961, 0.87017, 0.00725, 0.00000], -[962, 0.87886, 0.00672, 0.00000], -[963, 0.81517, 0.01333, 0.00000], -[964, 0.62600, 0.08743, 0.00000], -[965, 0.71000, 0.04330, 0.00000], -[966, 0.69000, 0.05196, 0.00000], -[967, 0.77520, 0.02165, 0.00000], -[968, 0.79747, 0.01645, 0.00000], -[969, 0.84002, 0.00928, 0.00000], -[970, 0.88720, 0.00578, 0.00000], -[971, 0.64750, 0.07361, 0.00000], -[972, 0.65500, 0.06928, 0.00000], -[973, 0.64000, 0.07794, 0.00000], -[974, 0.86159, 0.00679, 0.00000], -[975, 0.66250, 0.06495, 0.00000], -[976, 0.63250, 0.08227, 0.00000], -[977, 0.69750, 0.04763, 0.00000], -[978, 0.73000, 0.03464, 0.00000], -[979, 0.77977, 0.01961, 0.00000], -[980, 0.74250, 0.03031, 0.00000], -[981, 0.67000, 0.06062, 0.00000], -[982, 0.81972, 0.01137, 0.00000], -[983, 0.90000, 0.00489, 0.00000], -[984, 0.80202, 0.01438, 0.00000], -[985, 0.71750, 0.03897, 0.00000], -[986, 0.89151, 0.00466, 0.00000], -[987, 0.61500, 0.09300, 0.00000], -[988, 0.75634, 0.02549, 0.00000], -[989, 0.67750, 0.05629, 0.00000], -[990, 0.83200, 0.00893, 0.00000], -[991, 0.88276, 0.00441, 0.00000], -[992, 0.78433, 0.01757, 0.00000], -[993, 0.70500, 0.04330, 0.00000], -[994, 0.87435, 0.00458, 0.00000], -[995, 0.68500, 0.05196, 0.00000], -[996, 0.84435, 0.00679, 0.00000], -[997, 0.80663, 0.01229, 0.00000], -[998, 0.76202, 0.02280, 0.00000], -[999, 0.73750, 0.03031, 0.00000], -[1000, 0.85285, 0.00562, 0.00000], -[1001, 0.86603, 0.00450, 0.00000], -[1002, 0.72500, 0.03464, 0.00000], -[1003, 0.62100, 0.08743, 0.00000], -[1004, 0.75037, 0.02594, 0.00000], -[1005, 0.78890, 0.01553, 0.00000], -[1006, 0.65000, 0.06928, 0.00000], -[1007, 0.69250, 0.04763, 0.00000], -[1008, 0.64250, 0.07361, 0.00000], -[1009, 0.39500, 0.50800, 0.00000], -[1010, 0.65750, 0.06495, 0.00000], -[1011, 0.71250, 0.03897, 0.00000], -[1012, 0.82389, 0.00863, 0.00000], -[1013, 0.63500, 0.07794, 0.00000], -[1014, 0.76659, 0.02076, 0.00000], -[1015, 0.83581, 0.00680, 0.00000], -[1016, 0.85739, 0.00446, 0.00000], -[1017, 0.66500, 0.06062, 0.00000], -[1018, 0.62750, 0.08227, 0.00000], -[1019, 0.81121, 0.01029, 0.00000], -[1020, 0.67250, 0.05629, 0.00000], -[1021, 0.79346, 0.01349, 0.00000], -[1022, 0.70000, 0.04330, 0.00000], -[1023, 0.77115, 0.01872, 0.00000], -[1024, 0.73250, 0.03031, 0.00000], -[1025, 0.61000, 0.09300, 0.00000], -[1026, 0.84868, 0.00431, 0.00000], -[1027, 0.74500, 0.02598, 0.00000], -[1028, 0.68000, 0.05196, 0.00000], -[1029, 0.72000, 0.03464, 0.00000], -[1030, 0.77572, 0.01668, 0.00000], -[1031, 0.79795, 0.01147, 0.00000], -[1032, 0.70750, 0.03897, 0.00000], -[1033, 0.68750, 0.04763, 0.00000], -[1034, 0.84012, 0.00431, 0.00000], -[1035, 0.64500, 0.06928, 0.00000], -[1036, 0.61600, 0.08743, 0.00000], -[1037, 0.65250, 0.06495, 0.00000], -[1038, 0.63750, 0.07361, 0.00000], -[1039, 0.81543, 0.00755, 0.00000], -[1040, 0.78028, 0.01464, 0.00000], -[1041, 0.66000, 0.06062, 0.00000], -[1042, 0.75341, 0.02190, 0.00000], -[1043, 0.63000, 0.07794, 0.00000], -[1044, 0.82774, 0.00531, 0.00000], -[1045, 0.74000, 0.02598, 0.00000], -[1046, 0.72750, 0.03031, 0.00000], -[1047, 0.69500, 0.04330, 0.00000], -[1048, 0.90000, 0.00000, 0.00000], -[1049, 0.89500, 0.00000, 0.00000], -[1050, 0.66750, 0.05629, 0.00000], -[1051, 0.89000, 0.00000, 0.00000], -[1052, 0.80261, 0.00932, 0.00000], -[1053, 0.62250, 0.08227, 0.00000], -[1054, 0.88500, 0.00000, 0.00000], -[1055, 0.71500, 0.03464, 0.00000], -[1056, 0.75797, 0.01986, 0.00000], -[1057, 0.88000, 0.00000, 0.00000], -[1058, 0.83179, 0.00408, 0.00000], -[1059, 0.67500, 0.05196, 0.00000], -[1060, 0.78485, 0.01260, 0.00000], -[1061, 0.87500, 0.00000, 0.00000], -[1062, 0.87000, 0.00000, 0.00000], -[1063, 0.70250, 0.03897, 0.00000], -[1064, 0.81967, 0.00537, 0.00000], -[1065, 0.76254, 0.01782, 0.00000], -[1066, 0.68250, 0.04763, 0.00000], -[1067, 0.60500, 0.09300, 0.00000], -[1068, 0.86500, 0.00000, 0.00000], -[1069, 0.73500, 0.02598, 0.00000], -[1070, 0.86000, 0.00000, 0.00000], -[1071, 0.78941, 0.01056, 0.00000], -[1072, 0.72250, 0.03031, 0.00000], -[1073, 0.74750, 0.02165, 0.00000], -[1074, 0.76710, 0.01578, 0.00000], -[1075, 0.82371, 0.00383, 0.00000], -[1076, 0.69000, 0.04330, 0.00000], -[1077, 0.64750, 0.06495, 0.00000], -[1078, 0.64000, 0.06928, 0.00000], -[1079, 0.85500, 0.00000, 0.00000], -[1080, 0.39000, 0.50800, 0.00000], -[1081, 0.71000, 0.03464, 0.00000], -[1082, 0.65500, 0.06062, 0.00000], -[1083, 0.63250, 0.07361, 0.00000], -[1084, 0.61100, 0.08743, 0.00000], -[1085, 0.66250, 0.05629, 0.00000], -[1086, 0.85000, 0.00000, 0.00000], -[1087, 0.62500, 0.07794, 0.00000], -[1088, 0.80719, 0.00592, 0.00000], -[1089, 0.79398, 0.00852, 0.00000], -[1090, 0.77167, 0.01375, 0.00000], -[1091, 0.67000, 0.05196, 0.00000], -[1092, 0.69750, 0.03897, 0.00000], -[1093, 0.81177, 0.00475, 0.00000], -[1094, 0.61750, 0.08227, 0.00000], -[1095, 0.84500, 0.00000, 0.00000], -[1096, 0.73000, 0.02598, 0.00000], -[1097, 0.74250, 0.02165, 0.00000], -[1098, 0.67750, 0.04763, 0.00000], -[1099, 0.71750, 0.03031, 0.00000], -[1100, 0.77623, 0.01171, 0.00000], -[1101, 0.84000, 0.00000, 0.00000], -[1102, 0.70500, 0.03464, 0.00000], -[1103, 0.68500, 0.04330, 0.00000], -[1104, 0.60000, 0.09300, 0.00000], -[1105, 0.83500, 0.00000, 0.00000], -[1106, 0.75392, 0.01693, 0.00000], -[1107, 0.78080, 0.00967, 0.00000], -[1108, 0.64250, 0.06495, 0.00000], -[1109, 0.79876, 0.00561, 0.00000], -[1110, 0.65000, 0.06062, 0.00000], -[1111, 0.63500, 0.06928, 0.00000], -[1112, 0.65750, 0.05629, 0.00000], -[1113, 0.73750, 0.02165, 0.00000], -[1114, 0.62750, 0.07361, 0.00000], -[1115, 0.83000, 0.00000, 0.00000], -[1116, 0.72500, 0.02598, 0.00000], -[1117, 0.69250, 0.03897, 0.00000], -[1118, 0.75849, 0.01489, 0.00000], -[1119, 0.66500, 0.05196, 0.00000], -[1120, 0.75000, 0.01732, 0.00000], -[1121, 0.80271, 0.00417, 0.00000], -[1122, 0.60600, 0.08743, 0.00000], -[1123, 0.71250, 0.03031, 0.00000], -[1124, 0.62000, 0.07794, 0.00000], -[1125, 0.78536, 0.00763, 0.00000], -[1126, 0.82500, 0.00000, 0.00000], -[1127, 0.67250, 0.04763, 0.00000], -[1128, 0.61250, 0.08227, 0.00000], -[1129, 0.76305, 0.01285, 0.00000], -[1130, 0.70000, 0.03464, 0.00000], -[1131, 0.68000, 0.04330, 0.00000], -[1132, 0.82000, 0.00000, 0.00000], -[1133, 0.73250, 0.02165, 0.00000], -[1134, 0.76762, 0.01081, 0.00000], -[1135, 0.72000, 0.02598, 0.00000], -[1136, 0.74500, 0.01732, 0.00000], -[1137, 0.68750, 0.03897, 0.00000], -[1138, 0.64500, 0.06062, 0.00000], -[1139, 0.63750, 0.06495, 0.00000], -[1140, 0.38500, 0.50800, 0.00000], -[1141, 0.70750, 0.03031, 0.00000], -[1142, 0.59500, 0.09300, 0.00000], -[1143, 0.81500, 0.00000, 0.00000], -[1144, 0.65250, 0.05629, 0.00000], -[1145, 0.63000, 0.06928, 0.00000], -[1146, 0.77218, 0.00877, 0.00000], -[1147, 0.66000, 0.05196, 0.00000], -[1148, 0.62250, 0.07361, 0.00000], -[1149, 0.78979, 0.00445, 0.00000], -[1150, 0.66750, 0.04763, 0.00000], -[1151, 0.69500, 0.03464, 0.00000], -[1152, 0.81000, 0.00000, 0.00000], -[1153, 0.61500, 0.07794, 0.00000], -[1154, 0.60100, 0.08743, 0.00000], -[1155, 0.72750, 0.02165, 0.00000], -[1156, 0.74000, 0.01732, 0.00000], -[1157, 0.77675, 0.00673, 0.00000], -[1158, 0.71500, 0.02598, 0.00000], -[1159, 0.67500, 0.04330, 0.00000], -[1160, 0.75250, 0.01299, 0.00000], -[1161, 0.60750, 0.08227, 0.00000], -[1162, 0.80500, 0.00000, 0.00000], -[1163, 0.70250, 0.03031, 0.00000], -[1164, 0.68250, 0.03897, 0.00000], -[1165, 0.78132, 0.00469, 0.00000], -[1166, 0.64000, 0.06062, 0.00000], -[1167, 0.64750, 0.05629, 0.00000], -[1168, 0.63250, 0.06495, 0.00000], -[1169, 0.76428, 0.00856, 0.00000], -[1170, 0.73500, 0.01732, 0.00000], -[1171, 0.65500, 0.05196, 0.00000], -[1172, 0.72250, 0.02165, 0.00000], -[1173, 0.80000, 0.00000, 0.00000], -[1174, 0.62500, 0.06928, 0.00000], -[1175, 0.69000, 0.03464, 0.00000], -[1176, 0.74750, 0.01299, 0.00000], -[1177, 0.59000, 0.09300, 0.00000], -[1178, 0.66250, 0.04763, 0.00000], -[1179, 0.71000, 0.02598, 0.00000], -[1180, 0.61750, 0.07361, 0.00000], -[1181, 0.76010, 0.00897, 0.00000], -[1182, 0.67000, 0.04330, 0.00000], -[1183, 0.61000, 0.07794, 0.00000], -[1184, 0.79500, 0.00000, 0.00000], -[1185, 0.69750, 0.03031, 0.00000], -[1186, 0.59600, 0.08743, 0.00000], -[1187, 0.67750, 0.03897, 0.00000], -[1188, 0.76814, 0.00584, 0.00000], -[1189, 0.73000, 0.01732, 0.00000], -[1190, 0.60250, 0.08227, 0.00000], -[1191, 0.74250, 0.01299, 0.00000], -[1192, 0.71750, 0.02165, 0.00000], -[1193, 0.77241, 0.00427, 0.00000], -[1194, 0.79000, 0.00000, 0.00000], -[1195, 0.68500, 0.03464, 0.00000], -[1196, 0.64250, 0.05629, 0.00000], -[1197, 0.75500, 0.00866, 0.00000], -[1198, 0.70500, 0.02598, 0.00000], -[1199, 0.63500, 0.06062, 0.00000], -[1200, 0.38000, 0.50800, 0.00000], -[1201, 0.65000, 0.05196, 0.00000], -[1202, 0.62750, 0.06495, 0.00000], -[1203, 0.65750, 0.04763, 0.00000], -[1204, 0.62000, 0.06928, 0.00000], -[1205, 0.66500, 0.04330, 0.00000], -[1206, 0.69250, 0.03031, 0.00000], -[1207, 0.78500, 0.00000, 0.00000], -[1208, 0.61250, 0.07361, 0.00000], -[1209, 0.72500, 0.01732, 0.00000], -[1210, 0.73750, 0.01299, 0.00000], -[1211, 0.58500, 0.09300, 0.00000], -[1212, 0.71250, 0.02165, 0.00000], -[1213, 0.67250, 0.03897, 0.00000], -[1214, 0.75000, 0.00866, 0.00000], -[1215, 0.60500, 0.07794, 0.00000], -[1216, 0.70000, 0.02598, 0.00000], -[1217, 0.59100, 0.08743, 0.00000], -[1218, 0.78000, 0.00000, 0.00000], -[1219, 0.68000, 0.03464, 0.00000], -[1220, 0.76250, 0.00433, 0.00000], -[1221, 0.59750, 0.08227, 0.00000], -[1222, 0.63750, 0.05629, 0.00000], -[1223, 0.64500, 0.05196, 0.00000], -[1224, 0.63000, 0.06062, 0.00000], -[1225, 0.73250, 0.01299, 0.00000], -[1226, 0.72000, 0.01732, 0.00000], -[1227, 0.65250, 0.04763, 0.00000], -[1228, 0.62250, 0.06495, 0.00000], -[1229, 0.68750, 0.03031, 0.00000], -[1230, 0.74500, 0.00866, 0.00000], -[1231, 0.66000, 0.04330, 0.00000], -[1232, 0.70750, 0.02165, 0.00000], -[1233, 0.77500, 0.00000, 0.00000], -[1234, 0.61500, 0.06928, 0.00000], -[1235, 0.75750, 0.00433, 0.00000], -[1236, 0.66750, 0.03897, 0.00000], -[1237, 0.60750, 0.07361, 0.00000], -[1238, 0.69500, 0.02598, 0.00000], -[1239, 0.58000, 0.09300, 0.00000], -[1240, 0.67500, 0.03464, 0.00000], -[1241, 0.72750, 0.01299, 0.00000], -[1242, 0.74000, 0.00866, 0.00000], -[1243, 0.60000, 0.07794, 0.00000], -[1244, 0.77000, 0.00000, 0.00000], -[1245, 0.71500, 0.01732, 0.00000], -[1246, 0.58600, 0.08768, 0.00000], -[1247, 0.75250, 0.00433, 0.00000], -[1248, 0.68250, 0.03031, 0.00000], -[1249, 0.70250, 0.02165, 0.00000], -[1250, 0.64000, 0.05196, 0.00000], -[1251, 0.63250, 0.05629, 0.00000], -[1252, 0.37500, 0.50800, 0.00000], -[1253, 0.64750, 0.04763, 0.00000], -[1254, 0.62500, 0.06062, 0.00000], -[1255, 0.59250, 0.08227, 0.00000], -[1256, 0.65500, 0.04330, 0.00000], -[1257, 0.61750, 0.06495, 0.00000], -[1258, 0.76500, 0.00000, 0.00000], -[1259, 0.66250, 0.03897, 0.00000], -[1260, 0.69000, 0.02598, 0.00000], -[1261, 0.72250, 0.01299, 0.00000], -[1262, 0.73500, 0.00866, 0.00000], -[1263, 0.61000, 0.06928, 0.00000], -[1264, 0.71000, 0.01732, 0.00000], -[1265, 0.74750, 0.00433, 0.00000], -[1266, 0.67000, 0.03464, 0.00000], -[1267, 0.60250, 0.07361, 0.00000], -[1268, 0.69750, 0.02165, 0.00000], -[1269, 0.76000, 0.00000, 0.00000], -[1270, 0.67750, 0.03031, 0.00000], -[1271, 0.57500, 0.09300, 0.00000], -[1272, 0.59500, 0.07794, 0.00000], -[1273, 0.63500, 0.05196, 0.00000], -[1274, 0.73000, 0.00866, 0.00000], -[1275, 0.64250, 0.04763, 0.00000], -[1276, 0.62750, 0.05629, 0.00000], -[1277, 0.71750, 0.01299, 0.00000], -[1278, 0.65000, 0.04330, 0.00000], -[1279, 0.74250, 0.00433, 0.00000], -[1280, 0.62000, 0.06062, 0.00000], -[1281, 0.68500, 0.02598, 0.00000], -[1282, 0.58000, 0.08811, 0.00000], -[1283, 0.70500, 0.01732, 0.00000], -[1284, 0.65750, 0.03897, 0.00000], -[1285, 0.58750, 0.08227, 0.00000], -[1286, 0.61250, 0.06495, 0.00000], -[1287, 0.75500, 0.00000, 0.00000], -[1288, 0.66500, 0.03464, 0.00000], -[1289, 0.60500, 0.06928, 0.00000], -[1290, 0.69250, 0.02165, 0.00000], -[1291, 0.67250, 0.03031, 0.00000], -[1292, 0.72500, 0.00866, 0.00000], -[1293, 0.73750, 0.00433, 0.00000], -[1294, 0.71250, 0.01299, 0.00000], -[1295, 0.59750, 0.07361, 0.00000], -[1296, 0.75000, 0.00000, 0.00000], -[1297, 0.68000, 0.02598, 0.00000], -[1298, 0.70000, 0.01732, 0.00000], -[1299, 0.63750, 0.04763, 0.00000], -[1300, 0.63000, 0.05196, 0.00000], -[1301, 0.37000, 0.50800, 0.00000], -[1302, 0.64500, 0.04330, 0.00000], -[1303, 0.62250, 0.05629, 0.00000], -[1304, 0.59000, 0.07794, 0.00000], -[1305, 0.57000, 0.09300, 0.00000], -[1306, 0.65250, 0.03897, 0.00000], -[1307, 0.61500, 0.06062, 0.00000], -[1308, 0.66000, 0.03464, 0.00000], -[1309, 0.68750, 0.02165, 0.00000], -[1310, 0.73250, 0.00433, 0.00000], -[1311, 0.72000, 0.00866, 0.00000], -[1312, 0.60750, 0.06495, 0.00000], -[1313, 0.58250, 0.08227, 0.00000], -[1314, 0.74500, 0.00000, 0.00000], -[1315, 0.70750, 0.01299, 0.00000], -[1316, 0.66750, 0.03031, 0.00000], -[1317, 0.60000, 0.06928, 0.00000], -[1318, 0.69500, 0.01732, 0.00000], -[1319, 0.67500, 0.02598, 0.00000], -[1320, 0.57500, 0.08660, 0.00000], -[1321, 0.59250, 0.07361, 0.00000], -[1322, 0.72750, 0.00433, 0.00000], -[1323, 0.63250, 0.04763, 0.00000], -[1324, 0.64000, 0.04330, 0.00000], -[1325, 0.71500, 0.00866, 0.00000], -[1326, 0.62500, 0.05196, 0.00000], -[1327, 0.74000, 0.00000, 0.00000], -[1328, 0.64750, 0.03897, 0.00000], -[1329, 0.68250, 0.02165, 0.00000], -[1330, 0.61750, 0.05629, 0.00000], -[1331, 0.70250, 0.01299, 0.00000], -[1332, 0.65500, 0.03464, 0.00000], -[1333, 0.58500, 0.07794, 0.00000], -[1334, 0.61000, 0.06062, 0.00000], -[1335, 0.56500, 0.09300, 0.00000], -[1336, 0.66250, 0.03031, 0.00000], -[1337, 0.60250, 0.06495, 0.00000], -[1338, 0.69000, 0.01732, 0.00000], -[1339, 0.72250, 0.00433, 0.00000], -[1340, 0.67000, 0.02598, 0.00000], -[1341, 0.57750, 0.08227, 0.00000], -[1342, 0.73500, 0.00000, 0.00000], -[1343, 0.71000, 0.00866, 0.00000], -[1344, 0.59500, 0.06928, 0.00000], -[1345, 0.69750, 0.01299, 0.00000], -[1346, 0.67750, 0.02165, 0.00000], -[1347, 0.63500, 0.04330, 0.00000], -[1348, 0.62750, 0.04763, 0.00000], -[1349, 0.36500, 0.50800, 0.00000], -[1350, 0.64250, 0.03897, 0.00000], -[1351, 0.58750, 0.07361, 0.00000], -[1352, 0.62000, 0.05196, 0.00000], -[1353, 0.57000, 0.08660, 0.00000], -[1354, 0.65000, 0.03464, 0.00000], -[1355, 0.61250, 0.05629, 0.00000], -[1356, 0.73000, 0.00000, 0.00000], -[1357, 0.71750, 0.00433, 0.00000], -[1358, 0.68500, 0.01732, 0.00000], -[1359, 0.65750, 0.03031, 0.00000], -[1360, 0.60500, 0.06062, 0.00000], -[1361, 0.58000, 0.07794, 0.00000], -[1362, 0.70500, 0.00866, 0.00000], -[1363, 0.66500, 0.02598, 0.00000], -[1364, 0.59750, 0.06495, 0.00000], -[1365, 0.56000, 0.09300, 0.00000], -[1366, 0.69250, 0.01299, 0.00000], -[1367, 0.67250, 0.02165, 0.00000], -[1368, 0.57250, 0.08227, 0.00000], -[1369, 0.59000, 0.06928, 0.00000], -[1370, 0.72500, 0.00000, 0.00000], -[1371, 0.71250, 0.00433, 0.00000], -[1372, 0.63000, 0.04330, 0.00000], -[1373, 0.63750, 0.03897, 0.00000], -[1374, 0.62250, 0.04763, 0.00000], -[1375, 0.64500, 0.03464, 0.00000], -[1376, 0.68000, 0.01732, 0.00000], -[1377, 0.61500, 0.05196, 0.00000], -[1378, 0.70000, 0.00866, 0.00000], -[1379, 0.65250, 0.03031, 0.00000], -[1380, 0.58250, 0.07361, 0.00000], -[1381, 0.60750, 0.05629, 0.00000], -[1382, 0.66000, 0.02598, 0.00000], -[1383, 0.60000, 0.06062, 0.00000], -[1384, 0.56500, 0.08615, 0.00000], -[1385, 0.68750, 0.01299, 0.00000], -[1386, 0.72000, 0.00000, 0.00000], -[1387, 0.57500, 0.07794, 0.00000], -[1388, 0.66750, 0.02165, 0.00000], -[1389, 0.70750, 0.00433, 0.00000], -[1390, 0.59250, 0.06495, 0.00000], -[1391, 0.55500, 0.09300, 0.00000], -[1392, 0.69500, 0.00866, 0.00000], -[1393, 0.67500, 0.01732, 0.00000], -[1394, 0.63250, 0.03897, 0.00000], -[1395, 0.62500, 0.04330, 0.00000], -[1396, 0.36000, 0.50800, 0.00000], -[1397, 0.64000, 0.03464, 0.00000], -[1398, 0.58500, 0.06928, 0.00000], -[1399, 0.61750, 0.04763, 0.00000], -[1400, 0.56750, 0.08227, 0.00000], -[1401, 0.64750, 0.03031, 0.00000], -[1402, 0.61000, 0.05196, 0.00000], -[1403, 0.71500, 0.00000, 0.00000], -[1404, 0.68250, 0.01299, 0.00000], -[1405, 0.65500, 0.02598, 0.00000], -[1406, 0.60250, 0.05629, 0.00000], -[1407, 0.70250, 0.00433, 0.00000], -[1408, 0.57750, 0.07361, 0.00000], -[1409, 0.66250, 0.02165, 0.00000], -[1410, 0.59500, 0.06062, 0.00000], -[1411, 0.56000, 0.08660, 0.00000], -[1412, 0.69000, 0.00866, 0.00000], -[1413, 0.67000, 0.01732, 0.00000], -[1414, 0.57000, 0.07794, 0.00000], -[1415, 0.58750, 0.06495, 0.00000], -[1416, 0.71000, 0.00000, 0.00000], -[1417, 0.62750, 0.03897, 0.00000], -[1418, 0.63500, 0.03464, 0.00000], -[1419, 0.62000, 0.04330, 0.00000], -[1420, 0.64250, 0.03031, 0.00000], -[1421, 0.67750, 0.01299, 0.00000], -[1422, 0.61250, 0.04763, 0.00000], -[1423, 0.69750, 0.00433, 0.00000], -[1424, 0.55000, 0.09300, 0.00000], -[1425, 0.65000, 0.02598, 0.00000], -[1426, 0.58000, 0.06928, 0.00000], -[1427, 0.60500, 0.05196, 0.00000], -[1428, 0.56250, 0.08227, 0.00000], -[1429, 0.65750, 0.02165, 0.00000], -[1430, 0.59750, 0.05629, 0.00000], -[1431, 0.68500, 0.00866, 0.00000], -[1432, 0.57250, 0.07361, 0.00000], -[1433, 0.66500, 0.01732, 0.00000], -[1434, 0.70500, 0.00000, 0.00000], -[1435, 0.55438, 0.08757, 0.00000], -[1436, 0.59000, 0.06062, 0.00000], -[1437, 0.69250, 0.00433, 0.00000], -[1438, 0.67250, 0.01299, 0.00000], -[1439, 0.63000, 0.03464, 0.00000], -[1440, 0.62250, 0.03897, 0.00000], -[1441, 0.35500, 0.50800, 0.00000], -[1442, 0.63750, 0.03031, 0.00000], -[1443, 0.58250, 0.06495, 0.00000], -[1444, 0.61500, 0.04330, 0.00000], -[1445, 0.56500, 0.07794, 0.00000], -[1446, 0.64500, 0.02598, 0.00000], -[1447, 0.60750, 0.04763, 0.00000], -[1448, 0.55829, 0.08270, 0.00000], -[1449, 0.68000, 0.00866, 0.00000], -[1450, 0.65250, 0.02165, 0.00000], -[1451, 0.60000, 0.05196, 0.00000], -[1452, 0.70000, 0.00000, 0.00000], -[1453, 0.57500, 0.06928, 0.00000], -[1454, 0.54500, 0.09300, 0.00000], -[1455, 0.66000, 0.01732, 0.00000], -[1456, 0.59250, 0.05629, 0.00000], -[1457, 0.68750, 0.00433, 0.00000], -[1458, 0.66750, 0.01299, 0.00000], -[1459, 0.56750, 0.07361, 0.00000], -[1460, 0.58500, 0.06062, 0.00000], -[1461, 0.62500, 0.03464, 0.00000], -[1462, 0.63250, 0.03031, 0.00000], -[1463, 0.61750, 0.03897, 0.00000], -[1464, 0.64000, 0.02598, 0.00000], -[1465, 0.67500, 0.00866, 0.00000], -[1466, 0.61000, 0.04330, 0.00000], -[1467, 0.69500, 0.00000, 0.00000], -[1468, 0.54792, 0.08833, 0.00000], -[1469, 0.64750, 0.02165, 0.00000], -[1470, 0.57750, 0.06495, 0.00000], -[1471, 0.60250, 0.04763, 0.00000], -[1472, 0.56000, 0.07794, 0.00000], -[1473, 0.65500, 0.01732, 0.00000], -[1474, 0.68250, 0.00433, 0.00000], -[1475, 0.59500, 0.05196, 0.00000], -[1476, 0.57000, 0.06928, 0.00000], -[1477, 0.66250, 0.01299, 0.00000], -[1478, 0.58750, 0.05629, 0.00000], -[1479, 0.54000, 0.09300, 0.00000], -[1480, 0.69000, 0.00000, 0.00000], -[1481, 0.67000, 0.00866, 0.00000], -[1482, 0.62750, 0.03031, 0.00000], -[1483, 0.62000, 0.03464, 0.00000], -[1484, 0.54987, 0.08387, 0.00000], -[1485, 0.35000, 0.50800, 0.00000], -[1486, 0.58000, 0.06062, 0.00000], -[1487, 0.63500, 0.02598, 0.00000], -[1488, 0.56250, 0.07361, 0.00000], -[1489, 0.61250, 0.03897, 0.00000], -[1490, 0.64250, 0.02165, 0.00000], -[1491, 0.55393, 0.08007, 0.00000], -[1492, 0.60500, 0.04330, 0.00000], -[1493, 0.67750, 0.00433, 0.00000], -[1494, 0.65000, 0.01732, 0.00000], -[1495, 0.59750, 0.04763, 0.00000], -[1496, 0.57250, 0.06495, 0.00000], -[1497, 0.54250, 0.08867, 0.00000], -[1498, 0.65750, 0.01299, 0.00000], -[1499, 0.59000, 0.05196, 0.00000], -[1500, 0.68500, 0.00000, 0.00000], -[1501, 0.66500, 0.00866, 0.00000], -[1502, 0.56500, 0.06928, 0.00000], -[1503, 0.58250, 0.05629, 0.00000], -[1504, 0.62250, 0.03031, 0.00000], -[1505, 0.63000, 0.02598, 0.00000], -[1506, 0.61500, 0.03464, 0.00000], -[1507, 0.67250, 0.00433, 0.00000], -[1508, 0.63750, 0.02165, 0.00000], -[1509, 0.53500, 0.09300, 0.00000], -[1510, 0.54500, 0.08434, 0.00000], -[1511, 0.60750, 0.03897, 0.00000], -[1512, 0.57500, 0.06062, 0.00000], -[1513, 0.64500, 0.01732, 0.00000], -[1514, 0.55690, 0.07431, 0.00000], -[1515, 0.60000, 0.04330, 0.00000], -[1516, 0.65250, 0.01299, 0.00000], -[1517, 0.68000, 0.00000, 0.00000], -[1518, 0.59250, 0.04763, 0.00000], -[1519, 0.56750, 0.06495, 0.00000], -[1520, 0.66000, 0.00866, 0.00000], -[1521, 0.58500, 0.05196, 0.00000], -[1522, 0.53750, 0.08867, 0.00000], -[1523, 0.54750, 0.08001, 0.00000], -[1524, 0.66750, 0.00433, 0.00000], -[1525, 0.62500, 0.02598, 0.00000], -[1526, 0.61750, 0.03031, 0.00000], -[1527, 0.34500, 0.50800, 0.00000], -[1528, 0.57750, 0.05629, 0.00000], -[1529, 0.56000, 0.06928, 0.00000], -[1530, 0.63250, 0.02165, 0.00000], -[1531, 0.61000, 0.03464, 0.00000], -[1532, 0.64000, 0.01732, 0.00000], -[1533, 0.60250, 0.03897, 0.00000], -[1534, 0.67500, 0.00000, 0.00000], -[1535, 0.64750, 0.01299, 0.00000], -[1536, 0.59500, 0.04330, 0.00000], -[1537, 0.57000, 0.06062, 0.00000], -[1538, 0.54000, 0.08434, 0.00000], -[1539, 0.53000, 0.09300, 0.00000], -[1540, 0.55082, 0.07525, 0.00000], -[1541, 0.65500, 0.00866, 0.00000], -[1542, 0.58750, 0.04763, 0.00000], -[1543, 0.66250, 0.00433, 0.00000], -[1544, 0.56250, 0.06495, 0.00000], -[1545, 0.58000, 0.05196, 0.00000], -[1546, 0.62000, 0.02598, 0.00000], -[1547, 0.62750, 0.02165, 0.00000], -[1548, 0.61250, 0.03031, 0.00000], -[1549, 0.53250, 0.08867, 0.00000], -[1550, 0.67000, 0.00000, 0.00000], -[1551, 0.54250, 0.08001, 0.00000], -[1552, 0.63500, 0.01732, 0.00000], -[1553, 0.60500, 0.03464, 0.00000], -[1554, 0.57250, 0.05629, 0.00000], -[1555, 0.64250, 0.01299, 0.00000], -[1556, 0.55407, 0.07009, 0.00000], -[1557, 0.59750, 0.03897, 0.00000], -[1558, 0.65000, 0.00866, 0.00000], -[1559, 0.59000, 0.04330, 0.00000], -[1560, 0.56500, 0.06062, 0.00000], -[1561, 0.65750, 0.00433, 0.00000], -[1562, 0.53500, 0.08434, 0.00000], -[1563, 0.58250, 0.04763, 0.00000], -[1564, 0.52500, 0.09300, 0.00000], -[1565, 0.54500, 0.07568, 0.00000], -[1566, 0.66500, 0.00000, 0.00000], -[1567, 0.62250, 0.02165, 0.00000], -[1568, 0.61500, 0.02598, 0.00000], -[1569, 0.57500, 0.05196, 0.00000], -[1570, 0.55750, 0.06495, 0.00000], -[1571, 0.34000, 0.50800, 0.00000], -[1572, 0.63000, 0.01732, 0.00000], -[1573, 0.60750, 0.03031, 0.00000], -[1574, 0.63750, 0.01299, 0.00000], -[1575, 0.60000, 0.03464, 0.00000], -[1576, 0.64500, 0.00866, 0.00000], -[1577, 0.59250, 0.03897, 0.00000], -[1578, 0.53750, 0.08001, 0.00000], -[1579, 0.52750, 0.08867, 0.00000], -[1580, 0.56750, 0.05629, 0.00000], -[1581, 0.54750, 0.07135, 0.00000], -[1582, 0.65250, 0.00433, 0.00000], -[1583, 0.58500, 0.04330, 0.00000], -[1584, 0.66000, 0.00000, 0.00000], -[1585, 0.56000, 0.06062, 0.00000], -[1586, 0.57750, 0.04763, 0.00000], -[1587, 0.61750, 0.02165, 0.00000], -[1588, 0.53000, 0.08434, 0.00000], -[1589, 0.62500, 0.01732, 0.00000], -[1590, 0.61000, 0.02598, 0.00000], -[1591, 0.54000, 0.07568, 0.00000], -[1592, 0.63250, 0.01299, 0.00000], -[1593, 0.52000, 0.09300, 0.00000], -[1594, 0.60250, 0.03031, 0.00000], -[1595, 0.57000, 0.05196, 0.00000], -[1596, 0.64000, 0.00866, 0.00000], -[1597, 0.55151, 0.06578, 0.00000], -[1598, 0.59500, 0.03464, 0.00000], -[1599, 0.64750, 0.00433, 0.00000], -[1600, 0.58750, 0.03897, 0.00000], -[1601, 0.56250, 0.05629, 0.00000], -[1602, 0.65500, 0.00000, 0.00000], -[1603, 0.53250, 0.08001, 0.00000], -[1604, 0.52250, 0.08867, 0.00000], -[1605, 0.58000, 0.04330, 0.00000], -[1606, 0.54250, 0.07135, 0.00000], -[1607, 0.62000, 0.01732, 0.00000], -[1608, 0.55500, 0.06062, 0.00000], -[1609, 0.61250, 0.02165, 0.00000], -[1610, 0.57250, 0.04763, 0.00000], -[1611, 0.33500, 0.50800, 0.00000], -[1612, 0.62750, 0.01299, 0.00000], -[1613, 0.60500, 0.02598, 0.00000], -[1614, 0.63500, 0.00866, 0.00000], -[1615, 0.59750, 0.03031, 0.00000], -[1616, 0.64250, 0.00433, 0.00000], -[1617, 0.52500, 0.08434, 0.00000], -[1618, 0.53500, 0.07568, 0.00000], -[1619, 0.59000, 0.03464, 0.00000], -[1620, 0.56500, 0.05196, 0.00000], -[1621, 0.51500, 0.09300, 0.00000], -[1622, 0.65000, 0.00000, 0.00000], -[1623, 0.54574, 0.06620, 0.00000], -[1624, 0.58250, 0.03897, 0.00000], -[1625, 0.55750, 0.05629, 0.00000], -[1626, 0.57500, 0.04330, 0.00000], -[1627, 0.52750, 0.08001, 0.00000], -[1628, 0.61500, 0.01732, 0.00000], -[1629, 0.62250, 0.01299, 0.00000], -[1630, 0.53750, 0.07135, 0.00000], -[1631, 0.60750, 0.02165, 0.00000], -[1632, 0.51750, 0.08867, 0.00000], -[1633, 0.63000, 0.00866, 0.00000], -[1634, 0.60000, 0.02598, 0.00000], -[1635, 0.56750, 0.04763, 0.00000], -[1636, 0.63750, 0.00433, 0.00000], -[1637, 0.59250, 0.03031, 0.00000], -[1638, 0.54936, 0.06097, 0.00000], -[1639, 0.64500, 0.00000, 0.00000], -[1640, 0.58500, 0.03464, 0.00000], -[1641, 0.56000, 0.05196, 0.00000], -[1642, 0.53000, 0.07568, 0.00000], -[1643, 0.52000, 0.08434, 0.00000], -[1644, 0.57750, 0.03897, 0.00000], -[1645, 0.54000, 0.06702, 0.00000], -[1646, 0.51000, 0.09300, 0.00000], -[1647, 0.55250, 0.05629, 0.00000], -[1648, 0.61750, 0.01299, 0.00000], -[1649, 0.57000, 0.04330, 0.00000], -[1650, 0.61000, 0.01732, 0.00000], -[1651, 0.33000, 0.50800, 0.00000], -[1652, 0.62500, 0.00866, 0.00000], -[1653, 0.60250, 0.02165, 0.00000], -[1654, 0.63250, 0.00433, 0.00000], -[1655, 0.59500, 0.02598, 0.00000], -[1656, 0.64000, 0.00000, 0.00000], -[1657, 0.52250, 0.08001, 0.00000], -[1658, 0.53250, 0.07135, 0.00000], -[1659, 0.58750, 0.03031, 0.00000], -[1660, 0.56250, 0.04763, 0.00000], -[1661, 0.51250, 0.08867, 0.00000], -[1662, 0.58000, 0.03464, 0.00000], -[1663, 0.55500, 0.05196, 0.00000], -[1664, 0.54357, 0.06074, 0.00000], -[1665, 0.57250, 0.03897, 0.00000], -[1666, 0.52500, 0.07568, 0.00000], -[1667, 0.54787, 0.05681, 0.00000], -[1668, 0.53500, 0.06702, 0.00000], -[1669, 0.61250, 0.01299, 0.00000], -[1670, 0.51500, 0.08434, 0.00000], -[1671, 0.62000, 0.00866, 0.00000], -[1672, 0.60500, 0.01732, 0.00000], -[1673, 0.62750, 0.00433, 0.00000], -[1674, 0.59750, 0.02165, 0.00000], -[1675, 0.56500, 0.04330, 0.00000], -[1676, 0.50500, 0.09300, 0.00000], -[1677, 0.63500, 0.00000, 0.00000], -[1678, 0.59000, 0.02598, 0.00000], -[1679, 0.58250, 0.03031, 0.00000], -[1680, 0.55750, 0.04763, 0.00000], -[1681, 0.52750, 0.07135, 0.00000], -[1682, 0.51750, 0.08001, 0.00000], -[1683, 0.57500, 0.03464, 0.00000], -[1684, 0.53768, 0.06236, 0.00000], -[1685, 0.50750, 0.08867, 0.00000], -[1686, 0.55000, 0.05196, 0.00000], -[1687, 0.56750, 0.03897, 0.00000], -[1688, 0.61500, 0.00866, 0.00000], -[1689, 0.60750, 0.01299, 0.00000], -[1690, 0.32500, 0.50800, 0.00000], -[1691, 0.62250, 0.00433, 0.00000], -[1692, 0.60000, 0.01732, 0.00000], -[1693, 0.63000, 0.00000, 0.00000], -[1694, 0.59250, 0.02165, 0.00000], -[1695, 0.52000, 0.07568, 0.00000], -[1696, 0.53000, 0.06702, 0.00000], -[1697, 0.56000, 0.04330, 0.00000], -[1698, 0.58500, 0.02598, 0.00000], -[1699, 0.51000, 0.08434, 0.00000], -[1700, 0.57750, 0.03031, 0.00000], -[1701, 0.50000, 0.09300, 0.00000], -[1702, 0.53954, 0.05792, 0.00000], -[1703, 0.55250, 0.04763, 0.00000], -[1704, 0.54393, 0.05408, 0.00000], -[1705, 0.57000, 0.03464, 0.00000], -[1706, 0.52250, 0.07135, 0.00000], -[1707, 0.51250, 0.08001, 0.00000], -[1708, 0.53250, 0.06269, 0.00000], -[1709, 0.61000, 0.00866, 0.00000], -[1710, 0.61750, 0.00433, 0.00000], -[1711, 0.60250, 0.01299, 0.00000], -[1712, 0.62500, 0.00000, 0.00000], -[1713, 0.59500, 0.01732, 0.00000], -[1714, 0.50250, 0.08867, 0.00000], -[1715, 0.56250, 0.03897, 0.00000], -[1716, 0.58750, 0.02165, 0.00000], -[1717, 0.58000, 0.02598, 0.00000], -[1718, 0.55500, 0.04330, 0.00000], -[1719, 0.52500, 0.06702, 0.00000], -[1720, 0.51500, 0.07568, 0.00000], -[1721, 0.53500, 0.05836, 0.00000], -[1722, 0.57250, 0.03031, 0.00000], -[1723, 0.50500, 0.08434, 0.00000], -[1724, 0.54690, 0.04833, 0.00000], -[1725, 0.49500, 0.09300, 0.00000], -[1726, 0.56500, 0.03464, 0.00000], -[1727, 0.61250, 0.00433, 0.00000], -[1728, 0.60500, 0.00866, 0.00000], -[1729, 0.32000, 0.50800, 0.00000], -[1730, 0.62000, 0.00000, 0.00000], -[1731, 0.59750, 0.01299, 0.00000], -[1732, 0.59000, 0.01732, 0.00000], -[1733, 0.51750, 0.07135, 0.00000], -[1734, 0.52750, 0.06269, 0.00000], -[1735, 0.50750, 0.08001, 0.00000], -[1736, 0.55750, 0.03897, 0.00000], -[1737, 0.58250, 0.02165, 0.00000], -[1738, 0.53750, 0.05403, 0.00000], -[1739, 0.49750, 0.08867, 0.00000], -[1740, 0.57500, 0.02598, 0.00000], -[1741, 0.55000, 0.04330, 0.00000], -[1742, 0.56750, 0.03031, 0.00000], -[1743, 0.52000, 0.06702, 0.00000], -[1744, 0.51000, 0.07568, 0.00000], -[1745, 0.53000, 0.05836, 0.00000], -[1746, 0.60750, 0.00433, 0.00000], -[1747, 0.61500, 0.00000, 0.00000], -[1748, 0.60000, 0.00866, 0.00000], -[1749, 0.50000, 0.08434, 0.00000], -[1750, 0.59250, 0.01299, 0.00000], -[1751, 0.56000, 0.03464, 0.00000], -[1752, 0.58500, 0.01732, 0.00000], -[1753, 0.49000, 0.09300, 0.00000], -[1754, 0.57750, 0.02165, 0.00000], -[1755, 0.55250, 0.03897, 0.00000], -[1756, 0.54048, 0.04807, 0.00000], -[1757, 0.52250, 0.06269, 0.00000], -[1758, 0.51250, 0.07135, 0.00000], -[1759, 0.53250, 0.05403, 0.00000], -[1760, 0.50250, 0.08001, 0.00000], -[1761, 0.57000, 0.02598, 0.00000], -[1762, 0.49250, 0.08867, 0.00000], -[1763, 0.54500, 0.04330, 0.00000], -[1764, 0.56250, 0.03031, 0.00000], -[1765, 0.61000, 0.00000, 0.00000], -[1766, 0.60250, 0.00433, 0.00000], -[1767, 0.31500, 0.50800, 0.00000], -[1768, 0.59500, 0.00866, 0.00000], -[1769, 0.51500, 0.06702, 0.00000], -[1770, 0.58750, 0.01299, 0.00000], -[1771, 0.52500, 0.05836, 0.00000], -[1772, 0.50500, 0.07568, 0.00000], -[1773, 0.55500, 0.03464, 0.00000], -[1774, 0.58000, 0.01732, 0.00000], -[1775, 0.53500, 0.04970, 0.00000], -[1776, 0.49500, 0.08434, 0.00000], -[1777, 0.57250, 0.02165, 0.00000], -[1778, 0.54750, 0.03897, 0.00000], -[1779, 0.48500, 0.09300, 0.00000], -[1780, 0.56500, 0.02598, 0.00000], -[1781, 0.51750, 0.06269, 0.00000], -[1782, 0.50750, 0.07135, 0.00000], -[1783, 0.52750, 0.05403, 0.00000], -[1784, 0.60500, 0.00000, 0.00000], -[1785, 0.49750, 0.08001, 0.00000], -[1786, 0.59750, 0.00433, 0.00000], -[1787, 0.59000, 0.00866, 0.00000], -[1788, 0.55750, 0.03031, 0.00000], -[1789, 0.58250, 0.01299, 0.00000], -[1790, 0.54009, 0.04277, 0.00000], -[1791, 0.48750, 0.08867, 0.00000], -[1792, 0.57500, 0.01732, 0.00000], -[1793, 0.51000, 0.06702, 0.00000], -[1794, 0.55000, 0.03464, 0.00000], -[1795, 0.52000, 0.05836, 0.00000], -[1796, 0.50000, 0.07568, 0.00000], -[1797, 0.53000, 0.04970, 0.00000], -[1798, 0.56750, 0.02165, 0.00000], -[1799, 0.49000, 0.08434, 0.00000], -[1800, 0.54250, 0.03897, 0.00000], -[1801, 0.56000, 0.02598, 0.00000], -[1802, 0.53496, 0.04453, 0.00000], -[1803, 0.60000, 0.00000, 0.00000], -[1804, 0.31000, 0.50800, 0.00000], -[1805, 0.59250, 0.00433, 0.00000], -[1806, 0.51250, 0.06269, 0.00000], -[1807, 0.58500, 0.00866, 0.00000], -[1808, 0.52250, 0.05403, 0.00000], -[1809, 0.48000, 0.09300, 0.00000], -[1810, 0.50250, 0.07135, 0.00000], -[1811, 0.55250, 0.03031, 0.00000], -[1812, 0.57750, 0.01299, 0.00000], -[1813, 0.49250, 0.08001, 0.00000], -[1814, 0.57000, 0.01732, 0.00000], -[1815, 0.54500, 0.03464, 0.00000], -[1816, 0.48250, 0.08867, 0.00000], -[1817, 0.51500, 0.05836, 0.00000], -[1818, 0.56250, 0.02165, 0.00000], -[1819, 0.50500, 0.06702, 0.00000], -[1820, 0.49500, 0.07568, 0.00000], -[1821, 0.52551, 0.04887, 0.00000], -[1822, 0.59500, 0.00000, 0.00000], -[1823, 0.58750, 0.00433, 0.00000], -[1824, 0.55500, 0.02598, 0.00000], -[1825, 0.53750, 0.03897, 0.00000], -[1826, 0.48500, 0.08434, 0.00000], -[1827, 0.58000, 0.00866, 0.00000], -[1828, 0.57250, 0.01299, 0.00000], -[1829, 0.50750, 0.06269, 0.00000], -[1830, 0.54750, 0.03031, 0.00000], -[1831, 0.49750, 0.07135, 0.00000], -[1832, 0.52910, 0.04410, 0.00000], -[1833, 0.47500, 0.09300, 0.00000], -[1834, 0.56500, 0.01732, 0.00000], -[1835, 0.48750, 0.08001, 0.00000], -[1836, 0.51701, 0.05338, 0.00000], -[1837, 0.54000, 0.03464, 0.00000], -[1838, 0.55750, 0.02165, 0.00000], -[1839, 0.30500, 0.50800, 0.00000], -[1840, 0.59000, 0.00000, 0.00000], -[1841, 0.49013, 0.07653, 0.00000], -[1842, 0.51000, 0.05836, 0.00000], -[1843, 0.47750, 0.08867, 0.00000], -[1844, 0.58250, 0.00433, 0.00000], -[1845, 0.55000, 0.02598, 0.00000], -[1846, 0.57500, 0.00866, 0.00000], -[1847, 0.53250, 0.03897, 0.00000], -[1848, 0.49955, 0.06670, 0.00000], -[1849, 0.56750, 0.01299, 0.00000], -[1850, 0.48000, 0.08434, 0.00000], -[1851, 0.54250, 0.03031, 0.00000], -[1852, 0.51979, 0.04802, 0.00000], -[1853, 0.50250, 0.06269, 0.00000], -[1854, 0.56000, 0.01732, 0.00000], -[1855, 0.52412, 0.04358, 0.00000], -[1856, 0.47000, 0.09300, 0.00000], -[1857, 0.58500, 0.00000, 0.00000], -[1858, 0.55250, 0.02165, 0.00000], -[1859, 0.53500, 0.03464, 0.00000], -[1860, 0.48250, 0.08001, 0.00000], -[1861, 0.57750, 0.00433, 0.00000], -[1862, 0.49042, 0.07168, 0.00000], -[1863, 0.51125, 0.05300, 0.00000], -[1864, 0.50500, 0.05836, 0.00000], -[1865, 0.57000, 0.00866, 0.00000], -[1866, 0.54500, 0.02598, 0.00000], -[1867, 0.47250, 0.08867, 0.00000], -[1868, 0.48562, 0.07557, 0.00000], -[1869, 0.52750, 0.03897, 0.00000], -[1870, 0.56250, 0.01299, 0.00000], -[1871, 0.53750, 0.03031, 0.00000], -[1872, 0.55500, 0.01732, 0.00000], -[1873, 0.30000, 0.50800, 0.00000], -[1874, 0.47500, 0.08434, 0.00000], -[1875, 0.49351, 0.06631, 0.00000], -[1876, 0.58000, 0.00000, 0.00000], -[1877, 0.51354, 0.04849, 0.00000], -[1878, 0.54750, 0.02165, 0.00000], -[1879, 0.57250, 0.00433, 0.00000], -[1880, 0.53000, 0.03464, 0.00000], -[1881, 0.51996, 0.04251, 0.00000], -[1882, 0.46500, 0.09300, 0.00000], -[1883, 0.56500, 0.00866, 0.00000], -[1884, 0.47750, 0.08001, 0.00000], -[1885, 0.54000, 0.02598, 0.00000], -[1886, 0.49625, 0.06166, 0.00000], -[1887, 0.55750, 0.01299, 0.00000], -[1888, 0.52250, 0.03897, 0.00000], -[1889, 0.50511, 0.05335, 0.00000], -[1890, 0.46750, 0.08867, 0.00000], -[1891, 0.53250, 0.03031, 0.00000], -[1892, 0.55000, 0.01732, 0.00000], -[1893, 0.48000, 0.07568, 0.00000], -[1894, 0.57500, 0.00000, 0.00000], -[1895, 0.49963, 0.05670, 0.00000], -[1896, 0.51500, 0.04330, 0.00000], -[1897, 0.56750, 0.00433, 0.00000], -[1898, 0.54250, 0.02165, 0.00000], -[1899, 0.47000, 0.08434, 0.00000], -[1900, 0.48375, 0.07066, 0.00000], -[1901, 0.52500, 0.03464, 0.00000], -[1902, 0.56000, 0.00866, 0.00000], -[1903, 0.50790, 0.04818, 0.00000], -[1904, 0.53500, 0.02598, 0.00000], -[1905, 0.48736, 0.06582, 0.00000], -[1906, 0.55250, 0.01299, 0.00000], -[1907, 0.46000, 0.09300, 0.00000], -[1908, 0.47250, 0.08001, 0.00000], -[1909, 0.29500, 0.50800, 0.00000], -[1910, 0.51750, 0.03897, 0.00000], -[1911, 0.54500, 0.01732, 0.00000], -[1912, 0.52750, 0.03031, 0.00000], -[1913, 0.57000, 0.00000, 0.00000], -[1914, 0.46250, 0.08867, 0.00000], -[1915, 0.49046, 0.06125, 0.00000], -[1916, 0.47500, 0.07568, 0.00000], -[1917, 0.56250, 0.00433, 0.00000], -[1918, 0.53750, 0.02165, 0.00000], -[1919, 0.50000, 0.05196, 0.00000], -[1920, 0.51000, 0.04330, 0.00000], -[1921, 0.55500, 0.00866, 0.00000], -[1922, 0.52000, 0.03464, 0.00000], -[1923, 0.46500, 0.08434, 0.00000], -[1924, 0.47841, 0.07058, 0.00000], -[1925, 0.49312, 0.05681, 0.00000], -[1926, 0.53000, 0.02598, 0.00000], -[1927, 0.54750, 0.01299, 0.00000], -[1928, 0.50250, 0.04763, 0.00000], -[1929, 0.51250, 0.03897, 0.00000], -[1930, 0.46750, 0.08001, 0.00000], -[1931, 0.45500, 0.09300, 0.00000], -[1932, 0.56500, 0.00000, 0.00000], -[1933, 0.54000, 0.01732, 0.00000], -[1934, 0.48190, 0.06548, 0.00000], -[1935, 0.52250, 0.03031, 0.00000], -[1936, 0.55750, 0.00433, 0.00000], -[1937, 0.49545, 0.05208, 0.00000], -[1938, 0.53250, 0.02165, 0.00000], -[1939, 0.45750, 0.08867, 0.00000], -[1940, 0.47000, 0.07568, 0.00000], -[1941, 0.55000, 0.00866, 0.00000], -[1942, 0.50500, 0.04330, 0.00000], -[1943, 0.29000, 0.50800, 0.00000], -[1944, 0.51500, 0.03464, 0.00000], -[1945, 0.48500, 0.06062, 0.00000], -[1946, 0.54250, 0.01299, 0.00000], -[1947, 0.52500, 0.02598, 0.00000], -[1948, 0.46000, 0.08434, 0.00000], -[1949, 0.47316, 0.07043, 0.00000], -[1950, 0.56000, 0.00000, 0.00000], -[1951, 0.49750, 0.04763, 0.00000], -[1952, 0.53500, 0.01732, 0.00000], -[1953, 0.50750, 0.03897, 0.00000], -[1954, 0.48750, 0.05629, 0.00000], -[1955, 0.55250, 0.00433, 0.00000], -[1956, 0.51750, 0.03031, 0.00000], -[1957, 0.46250, 0.08001, 0.00000], -[1958, 0.45000, 0.09300, 0.00000], -[1959, 0.47663, 0.06554, 0.00000], -[1960, 0.52750, 0.02165, 0.00000], -[1961, 0.54500, 0.00866, 0.00000], -[1962, 0.50000, 0.04330, 0.00000], -[1963, 0.49000, 0.05196, 0.00000], -[1964, 0.51000, 0.03464, 0.00000], -[1965, 0.53750, 0.01299, 0.00000], -[1966, 0.48000, 0.06062, 0.00000], -[1967, 0.52000, 0.02598, 0.00000], -[1968, 0.46459, 0.07509, 0.00000], -[1969, 0.55500, 0.00000, 0.00000], -[1970, 0.53000, 0.01732, 0.00000], -[1971, 0.45143, 0.08779, 0.00000], -[1972, 0.54750, 0.00433, 0.00000], -[1973, 0.50250, 0.03897, 0.00000], -[1974, 0.49250, 0.04763, 0.00000], -[1975, 0.28500, 0.50800, 0.00000], -[1976, 0.51250, 0.03031, 0.00000], -[1977, 0.48250, 0.05629, 0.00000], -[1978, 0.54000, 0.00866, 0.00000], -[1979, 0.52250, 0.02165, 0.00000], -[1980, 0.45402, 0.08353, 0.00000], -[1981, 0.44500, 0.09300, 0.00000], -[1982, 0.46732, 0.06970, 0.00000], -[1983, 0.47163, 0.06524, 0.00000], -[1984, 0.49500, 0.04330, 0.00000], -[1985, 0.53250, 0.01299, 0.00000], -[1986, 0.50500, 0.03464, 0.00000], -[1987, 0.48500, 0.05196, 0.00000], -[1988, 0.55000, 0.00000, 0.00000], -[1989, 0.51500, 0.02598, 0.00000], -[1990, 0.45649, 0.07918, 0.00000], -[1991, 0.47500, 0.06062, 0.00000], -[1992, 0.52500, 0.01732, 0.00000], -[1993, 0.54250, 0.00433, 0.00000], -[1994, 0.49750, 0.03897, 0.00000], -[1995, 0.48750, 0.04763, 0.00000], -[1996, 0.45896, 0.07482, 0.00000], -[1997, 0.50750, 0.03031, 0.00000], -[1998, 0.47750, 0.05629, 0.00000], -[1999, 0.53500, 0.00866, 0.00000], -[2000, 0.51750, 0.02165, 0.00000], -[2001, 0.44607, 0.08749, 0.00000], -[2002, 0.52750, 0.01299, 0.00000], -[2003, 0.44000, 0.09300, 0.00000], -[2004, 0.49000, 0.04330, 0.00000], -[2005, 0.50000, 0.03464, 0.00000], -[2006, 0.46125, 0.07032, 0.00000], -[2007, 0.46746, 0.06417, 0.00000], -[2008, 0.54500, 0.00000, 0.00000], -[2009, 0.48000, 0.05196, 0.00000], -[2010, 0.28000, 0.50800, 0.00000], -[2011, 0.51000, 0.02598, 0.00000], -[2012, 0.44818, 0.08284, 0.00000], -[2013, 0.47000, 0.06062, 0.00000], -[2014, 0.53750, 0.00433, 0.00000], -[2015, 0.52000, 0.01732, 0.00000], -[2016, 0.49250, 0.03897, 0.00000], -[2017, 0.50250, 0.03031, 0.00000], -[2018, 0.53000, 0.00866, 0.00000], -[2019, 0.48250, 0.04763, 0.00000], -[2020, 0.45051, 0.07837, 0.00000], -[2021, 0.51250, 0.02165, 0.00000], -[2022, 0.47250, 0.05629, 0.00000], -[2023, 0.52250, 0.01299, 0.00000], -[2024, 0.44101, 0.08744, 0.00000], -[2025, 0.54000, 0.00000, 0.00000], -[2026, 0.46250, 0.06495, 0.00000], -[2027, 0.49500, 0.03464, 0.00000], -[2028, 0.45299, 0.07402, 0.00000], -[2029, 0.48500, 0.04330, 0.00000], -[2030, 0.50500, 0.02598, 0.00000], -[2031, 0.43500, 0.09300, 0.00000], -[2032, 0.47500, 0.05196, 0.00000], -[2033, 0.53250, 0.00433, 0.00000], -[2034, 0.51500, 0.01732, 0.00000], -[2035, 0.46500, 0.06062, 0.00000], -[2036, 0.45553, 0.06972, 0.00000], -[2037, 0.52500, 0.00866, 0.00000], -[2038, 0.48750, 0.03897, 0.00000], -[2039, 0.49750, 0.03031, 0.00000], -[2040, 0.47750, 0.04763, 0.00000], -[2041, 0.44250, 0.08227, 0.00000], -[2042, 0.50750, 0.02165, 0.00000], -[2043, 0.27500, 0.50800, 0.00000], -[2044, 0.46750, 0.05629, 0.00000], -[2045, 0.53500, 0.00000, 0.00000], -[2046, 0.51750, 0.01299, 0.00000], -[2047, 0.44500, 0.07794, 0.00000], -[2048, 0.45750, 0.06495, 0.00000], -[2049, 0.49000, 0.03464, 0.00000], -[2050, 0.43600, 0.08743, 0.00000], -[2051, 0.50000, 0.02598, 0.00000], -[2052, 0.48000, 0.04330, 0.00000], -[2053, 0.52750, 0.00433, 0.00000], -[2054, 0.51000, 0.01732, 0.00000], -[2055, 0.47000, 0.05196, 0.00000], -[2056, 0.43000, 0.09300, 0.00000], -[2057, 0.44750, 0.07361, 0.00000], -[2058, 0.52000, 0.00866, 0.00000], -[2059, 0.46000, 0.06062, 0.00000], -[2060, 0.49250, 0.03031, 0.00000], -[2061, 0.48250, 0.03897, 0.00000], -[2062, 0.50250, 0.02165, 0.00000], -[2063, 0.47250, 0.04763, 0.00000], -[2064, 0.53000, 0.00000, 0.00000], -[2065, 0.45000, 0.06928, 0.00000], -[2066, 0.43750, 0.08227, 0.00000], -[2067, 0.51250, 0.01299, 0.00000], -[2068, 0.46250, 0.05629, 0.00000], -[2069, 0.52250, 0.00433, 0.00000], -[2070, 0.48500, 0.03464, 0.00000], -[2071, 0.49500, 0.02598, 0.00000], -[2072, 0.45250, 0.06495, 0.00000], -[2073, 0.44000, 0.07794, 0.00000], -[2074, 0.47500, 0.04330, 0.00000], -[2075, 0.50500, 0.01732, 0.00000], -[2076, 0.43100, 0.08743, 0.00000], -[2077, 0.27000, 0.50800, 0.00000], -[2078, 0.46500, 0.05196, 0.00000], -[2079, 0.51500, 0.00866, 0.00000], -[2080, 0.42500, 0.09300, 0.00000], -[2081, 0.44250, 0.07361, 0.00000], -[2082, 0.45500, 0.06062, 0.00000], -[2083, 0.48750, 0.03031, 0.00000], -[2084, 0.47750, 0.03897, 0.00000], -[2085, 0.49750, 0.02165, 0.00000], -[2086, 0.52500, 0.00000, 0.00000], -[2087, 0.46750, 0.04763, 0.00000], -[2088, 0.50750, 0.01299, 0.00000], -[2089, 0.44500, 0.06928, 0.00000], -[2090, 0.43250, 0.08227, 0.00000], -[2091, 0.45750, 0.05629, 0.00000], -[2092, 0.51750, 0.00433, 0.00000], -[2093, 0.49000, 0.02598, 0.00000], -[2094, 0.48000, 0.03464, 0.00000], -[2095, 0.50000, 0.01732, 0.00000], -[2096, 0.47000, 0.04330, 0.00000], -[2097, 0.44750, 0.06495, 0.00000], -[2098, 0.43500, 0.07794, 0.00000], -[2099, 0.51000, 0.00866, 0.00000], -[2100, 0.42600, 0.08743, 0.00000], -[2101, 0.46000, 0.05196, 0.00000], -[2102, 0.52000, 0.00000, 0.00000], -[2103, 0.48250, 0.03031, 0.00000], -[2104, 0.49250, 0.02165, 0.00000], -[2105, 0.43750, 0.07361, 0.00000], -[2106, 0.42000, 0.09300, 0.00000], -[2107, 0.45000, 0.06062, 0.00000], -[2108, 0.47250, 0.03897, 0.00000], -[2109, 0.50250, 0.01299, 0.00000], -[2110, 0.26500, 0.50800, 0.00000], -[2111, 0.46250, 0.04763, 0.00000], -[2112, 0.51250, 0.00433, 0.00000], -[2113, 0.44000, 0.06928, 0.00000], -[2114, 0.45250, 0.05629, 0.00000], -[2115, 0.42750, 0.08227, 0.00000], -[2116, 0.48500, 0.02598, 0.00000], -[2117, 0.47500, 0.03464, 0.00000], -[2118, 0.49500, 0.01732, 0.00000], -[2119, 0.46500, 0.04330, 0.00000], -[2120, 0.50500, 0.00866, 0.00000], -[2121, 0.44250, 0.06495, 0.00000], -[2122, 0.43000, 0.07794, 0.00000], -[2123, 0.45500, 0.05196, 0.00000], -[2124, 0.51500, 0.00000, 0.00000], -[2125, 0.42100, 0.08743, 0.00000], -[2126, 0.48750, 0.02165, 0.00000], -[2127, 0.47750, 0.03031, 0.00000], -[2128, 0.49750, 0.01299, 0.00000], -[2129, 0.46750, 0.03897, 0.00000], -[2130, 0.44500, 0.06062, 0.00000], -[2131, 0.43250, 0.07361, 0.00000], -[2132, 0.41500, 0.09300, 0.00000], -[2133, 0.50750, 0.00433, 0.00000], -[2134, 0.45750, 0.04763, 0.00000], -[2135, 0.43500, 0.06928, 0.00000], -[2136, 0.48000, 0.02598, 0.00000], -[2137, 0.44750, 0.05629, 0.00000], -[2138, 0.49000, 0.01732, 0.00000], -[2139, 0.47000, 0.03464, 0.00000], -[2140, 0.42250, 0.08227, 0.00000], -[2141, 0.50000, 0.00866, 0.00000], -[2142, 0.46000, 0.04330, 0.00000], -[2143, 0.26000, 0.50800, 0.00000], -[2144, 0.51000, 0.00000, 0.00000], -[2145, 0.43750, 0.06495, 0.00000], -[2146, 0.45000, 0.05196, 0.00000], -[2147, 0.42500, 0.07794, 0.00000], -[2148, 0.48250, 0.02165, 0.00000], -[2149, 0.47250, 0.03031, 0.00000], -[2150, 0.49250, 0.01299, 0.00000], -[2151, 0.41600, 0.08743, 0.00000], -[2152, 0.46250, 0.03897, 0.00000], -[2153, 0.50250, 0.00433, 0.00000], -[2154, 0.44000, 0.06062, 0.00000], -[2155, 0.42750, 0.07361, 0.00000], -[2156, 0.45250, 0.04763, 0.00000], -[2157, 0.41000, 0.09300, 0.00000], -[2158, 0.47500, 0.02598, 0.00000], -[2159, 0.48500, 0.01732, 0.00000], -[2160, 0.46500, 0.03464, 0.00000], -[2161, 0.44250, 0.05629, 0.00000], -[2162, 0.49500, 0.00866, 0.00000], -[2163, 0.43000, 0.06928, 0.00000], -[2164, 0.45500, 0.04330, 0.00000], -[2165, 0.41750, 0.08227, 0.00000], -[2166, 0.50500, 0.00000, 0.00000], -[2167, 0.43250, 0.06495, 0.00000], -[2168, 0.44500, 0.05196, 0.00000], -[2169, 0.47750, 0.02165, 0.00000], -[2170, 0.48750, 0.01299, 0.00000], -[2171, 0.46750, 0.03031, 0.00000], -[2172, 0.42000, 0.07794, 0.00000], -[2173, 0.49750, 0.00433, 0.00000], -[2174, 0.45750, 0.03897, 0.00000], -[2175, 0.41100, 0.08743, 0.00000], -[2176, 0.25500, 0.50800, 0.00000], -[2177, 0.43500, 0.06062, 0.00000], -[2178, 0.44750, 0.04763, 0.00000], -[2179, 0.42250, 0.07361, 0.00000], -[2180, 0.48000, 0.01732, 0.00000], -[2181, 0.47000, 0.02598, 0.00000], -[2182, 0.40500, 0.09300, 0.00000], -[2183, 0.49000, 0.00866, 0.00000], -[2184, 0.46000, 0.03464, 0.00000], -[2185, 0.43750, 0.05629, 0.00000], -[2186, 0.50000, 0.00000, 0.00000], -[2187, 0.42500, 0.06928, 0.00000], -[2188, 0.45000, 0.04330, 0.00000], -[2189, 0.41250, 0.08227, 0.00000], -[2190, 0.47250, 0.02165, 0.00000], -[2191, 0.48250, 0.01299, 0.00000], -[2192, 0.42750, 0.06495, 0.00000], -[2193, 0.44000, 0.05196, 0.00000], -[2194, 0.46250, 0.03031, 0.00000], -[2195, 0.49250, 0.00433, 0.00000], -[2196, 0.41500, 0.07794, 0.00000], -[2197, 0.45250, 0.03897, 0.00000], -[2198, 0.40600, 0.08768, 0.00000], -[2199, 0.43000, 0.06062, 0.00000], -[2200, 0.44250, 0.04763, 0.00000], -[2201, 0.47500, 0.01732, 0.00000], -[2202, 0.41750, 0.07361, 0.00000], -[2203, 0.48500, 0.00866, 0.00000], -[2204, 0.46500, 0.02598, 0.00000], -[2205, 0.49500, 0.00000, 0.00000], -[2206, 0.45500, 0.03464, 0.00000], -[2207, 0.40000, 0.09300, 0.00000], -[2208, 0.25000, 0.50800, 0.00000], -[2209, 0.43250, 0.05629, 0.00000], -[2210, 0.42000, 0.06928, 0.00000], -[2211, 0.44500, 0.04330, 0.00000], -[2212, 0.47750, 0.01299, 0.00000], -[2213, 0.46750, 0.02165, 0.00000], -[2214, 0.40750, 0.08227, 0.00000], -[2215, 0.48750, 0.00433, 0.00000], -[2216, 0.45750, 0.03031, 0.00000], -[2217, 0.43500, 0.05196, 0.00000], -[2218, 0.42250, 0.06495, 0.00000], -[2219, 0.44750, 0.03897, 0.00000], -[2220, 0.41000, 0.07794, 0.00000], -[2221, 0.47000, 0.01732, 0.00000], -[2222, 0.48000, 0.00866, 0.00000], -[2223, 0.42500, 0.06062, 0.00000], -[2224, 0.43750, 0.04763, 0.00000], -[2225, 0.46000, 0.02598, 0.00000], -[2226, 0.49000, 0.00000, 0.00000], -[2227, 0.40000, 0.08811, 0.00000], -[2228, 0.41250, 0.07361, 0.00000], -[2229, 0.45000, 0.03464, 0.00000], -[2230, 0.39500, 0.09300, 0.00000], -[2231, 0.42750, 0.05629, 0.00000], -[2232, 0.44000, 0.04330, 0.00000], -[2233, 0.41500, 0.06928, 0.00000], -[2234, 0.47250, 0.01299, 0.00000], -[2235, 0.46250, 0.02165, 0.00000], -[2236, 0.48250, 0.00433, 0.00000], -[2237, 0.45250, 0.03031, 0.00000], -[2238, 0.40250, 0.08227, 0.00000], -[2239, 0.43000, 0.05196, 0.00000], -[2240, 0.24500, 0.50800, 0.00000], -[2241, 0.41750, 0.06495, 0.00000], -[2242, 0.44250, 0.03897, 0.00000], -[2243, 0.47500, 0.00866, 0.00000], -[2244, 0.40500, 0.07794, 0.00000], -[2245, 0.46500, 0.01732, 0.00000], -[2246, 0.48500, 0.00000, 0.00000], -[2247, 0.45500, 0.02598, 0.00000], -[2248, 0.43250, 0.04763, 0.00000], -[2249, 0.42000, 0.06062, 0.00000], -[2250, 0.44500, 0.03464, 0.00000], -[2251, 0.40750, 0.07361, 0.00000], -[2252, 0.42250, 0.05629, 0.00000], -[2253, 0.46750, 0.01299, 0.00000], -[2254, 0.43500, 0.04330, 0.00000], -[2255, 0.47750, 0.00433, 0.00000], -[2256, 0.39000, 0.09300, 0.00000], -[2257, 0.45750, 0.02165, 0.00000], -[2258, 0.41000, 0.06928, 0.00000], -[2259, 0.39500, 0.08660, 0.00000], -[2260, 0.44750, 0.03031, 0.00000], -[2261, 0.42500, 0.05196, 0.00000], -[2262, 0.39750, 0.08227, 0.00000], -[2263, 0.43750, 0.03897, 0.00000], -[2264, 0.41250, 0.06495, 0.00000], -[2265, 0.47000, 0.00866, 0.00000], -[2266, 0.46000, 0.01732, 0.00000], -[2267, 0.48000, 0.00000, 0.00000], -[2268, 0.45000, 0.02598, 0.00000], -[2269, 0.40000, 0.07794, 0.00000], -[2270, 0.42750, 0.04763, 0.00000], -[2271, 0.41500, 0.06062, 0.00000], -[2272, 0.24000, 0.50800, 0.00000], -[2273, 0.44000, 0.03464, 0.00000], -[2274, 0.40250, 0.07361, 0.00000], -[2275, 0.47250, 0.00433, 0.00000], -[2276, 0.46250, 0.01299, 0.00000], -[2277, 0.45250, 0.02165, 0.00000], -[2278, 0.43000, 0.04330, 0.00000], -[2279, 0.41750, 0.05629, 0.00000], -[2280, 0.38500, 0.09300, 0.00000], -[2281, 0.44250, 0.03031, 0.00000], -[2282, 0.40500, 0.06928, 0.00000], -[2283, 0.39000, 0.08660, 0.00000], -[2284, 0.42000, 0.05196, 0.00000], -[2285, 0.43250, 0.03897, 0.00000], -[2286, 0.46500, 0.00866, 0.00000], -[2287, 0.47500, 0.00000, 0.00000], -[2288, 0.45500, 0.01732, 0.00000], -[2289, 0.39250, 0.08227, 0.00000], -[2290, 0.40750, 0.06495, 0.00000], -[2291, 0.44500, 0.02598, 0.00000], -[2292, 0.42250, 0.04763, 0.00000], -[2293, 0.39500, 0.07794, 0.00000], -[2294, 0.41000, 0.06062, 0.00000], -[2295, 0.43500, 0.03464, 0.00000], -[2296, 0.46750, 0.00433, 0.00000], -[2297, 0.45750, 0.01299, 0.00000], -[2298, 0.39750, 0.07361, 0.00000], -[2299, 0.44750, 0.02165, 0.00000], -[2300, 0.42500, 0.04330, 0.00000], -[2301, 0.41250, 0.05629, 0.00000], -[2302, 0.43750, 0.03031, 0.00000], -[2303, 0.23500, 0.50800, 0.00000], -[2304, 0.40000, 0.06928, 0.00000], -[2305, 0.38000, 0.09300, 0.00000], -[2306, 0.38500, 0.08660, 0.00000], -[2307, 0.46000, 0.00866, 0.00000], -[2308, 0.47000, 0.00000, 0.00000], -[2309, 0.41500, 0.05196, 0.00000], -[2310, 0.42750, 0.03897, 0.00000], -[2311, 0.45000, 0.01732, 0.00000], -[2312, 0.40250, 0.06495, 0.00000], -[2313, 0.38750, 0.08227, 0.00000], -[2314, 0.44000, 0.02598, 0.00000], -[2315, 0.41750, 0.04763, 0.00000], -[2316, 0.43000, 0.03464, 0.00000], -[2317, 0.39000, 0.07794, 0.00000], -[2318, 0.46250, 0.00433, 0.00000], -[2319, 0.40500, 0.06062, 0.00000], -[2320, 0.45250, 0.01299, 0.00000], -[2321, 0.44250, 0.02165, 0.00000], -[2322, 0.39250, 0.07361, 0.00000], -[2323, 0.42000, 0.04330, 0.00000], -[2324, 0.40750, 0.05629, 0.00000], -[2325, 0.43250, 0.03031, 0.00000], -[2326, 0.46500, 0.00000, 0.00000], -[2327, 0.45500, 0.00866, 0.00000], -[2328, 0.39500, 0.06928, 0.00000], -[2329, 0.44500, 0.01732, 0.00000], -[2330, 0.37500, 0.09300, 0.00000], -[2331, 0.38000, 0.08660, 0.00000], -[2332, 0.42250, 0.03897, 0.00000], -[2333, 0.41000, 0.05196, 0.00000], -[2334, 0.43500, 0.02598, 0.00000], -[2335, 0.39750, 0.06495, 0.00000], -[2336, 0.23000, 0.50800, 0.00000], -[2337, 0.38250, 0.08227, 0.00000], -[2338, 0.45750, 0.00433, 0.00000], -[2339, 0.41250, 0.04763, 0.00000], -[2340, 0.42500, 0.03464, 0.00000], -[2341, 0.44750, 0.01299, 0.00000], -[2342, 0.40000, 0.06062, 0.00000], -[2343, 0.38500, 0.07794, 0.00000], -[2344, 0.43750, 0.02165, 0.00000], -[2345, 0.41500, 0.04330, 0.00000], -[2346, 0.38750, 0.07361, 0.00000], -[2347, 0.42750, 0.03031, 0.00000], -[2348, 0.40250, 0.05629, 0.00000], -[2349, 0.46000, 0.00000, 0.00000], -[2350, 0.45000, 0.00866, 0.00000], -[2351, 0.44000, 0.01732, 0.00000], -[2352, 0.39000, 0.06928, 0.00000], -[2353, 0.41750, 0.03897, 0.00000], -[2354, 0.40500, 0.05196, 0.00000], -[2355, 0.37000, 0.09300, 0.00000], -[2356, 0.43000, 0.02598, 0.00000], -[2357, 0.37500, 0.08615, 0.00000], -[2358, 0.39250, 0.06495, 0.00000], -[2359, 0.45250, 0.00433, 0.00000], -[2360, 0.37750, 0.08227, 0.00000], -[2361, 0.44250, 0.01299, 0.00000], -[2362, 0.42000, 0.03464, 0.00000], -[2363, 0.40750, 0.04763, 0.00000], -[2364, 0.43250, 0.02165, 0.00000], -[2365, 0.39500, 0.06062, 0.00000], -[2366, 0.38000, 0.07794, 0.00000], -[2367, 0.22500, 0.50800, 0.00000], -[2368, 0.41000, 0.04330, 0.00000], -[2369, 0.45500, 0.00000, 0.00000], -[2370, 0.42250, 0.03031, 0.00000], -[2371, 0.44500, 0.00866, 0.00000], -[2372, 0.38250, 0.07361, 0.00000], -[2373, 0.39750, 0.05629, 0.00000], -[2374, 0.43500, 0.01732, 0.00000], -[2375, 0.41250, 0.03897, 0.00000], -[2376, 0.38500, 0.06928, 0.00000], -[2377, 0.42500, 0.02598, 0.00000], -[2378, 0.40000, 0.05196, 0.00000], -[2379, 0.44750, 0.00433, 0.00000], -[2380, 0.36500, 0.09300, 0.00000], -[2381, 0.37000, 0.08660, 0.00000], -[2382, 0.43750, 0.01299, 0.00000], -[2383, 0.38750, 0.06495, 0.00000], -[2384, 0.41500, 0.03464, 0.00000], -[2385, 0.40250, 0.04763, 0.00000], -[2386, 0.37250, 0.08227, 0.00000], -[2387, 0.42750, 0.02165, 0.00000], -[2388, 0.39000, 0.06062, 0.00000], -[2389, 0.45000, 0.00000, 0.00000], -[2390, 0.37500, 0.07794, 0.00000], -[2391, 0.44000, 0.00866, 0.00000], -[2392, 0.40500, 0.04330, 0.00000], -[2393, 0.41750, 0.03031, 0.00000], -[2394, 0.39250, 0.05629, 0.00000], -[2395, 0.43000, 0.01732, 0.00000], -[2396, 0.37750, 0.07361, 0.00000], -[2397, 0.22000, 0.50800, 0.00000], -[2398, 0.40750, 0.03897, 0.00000], -[2399, 0.42000, 0.02598, 0.00000], -[2400, 0.38000, 0.06928, 0.00000], -[2401, 0.44250, 0.00433, 0.00000], -[2402, 0.39500, 0.05196, 0.00000], -[2403, 0.43250, 0.01299, 0.00000], -[2404, 0.36500, 0.08660, 0.00000], -[2405, 0.36000, 0.09300, 0.00000], -[2406, 0.38250, 0.06495, 0.00000], -[2407, 0.41000, 0.03464, 0.00000], -[2408, 0.39750, 0.04763, 0.00000], -[2409, 0.42250, 0.02165, 0.00000], -[2410, 0.36750, 0.08227, 0.00000], -[2411, 0.44500, 0.00000, 0.00000], -[2412, 0.38500, 0.06062, 0.00000], -[2413, 0.43500, 0.00866, 0.00000], -[2414, 0.41250, 0.03031, 0.00000], -[2415, 0.37000, 0.07794, 0.00000], -[2416, 0.40000, 0.04330, 0.00000], -[2417, 0.42500, 0.01732, 0.00000], -[2418, 0.38750, 0.05629, 0.00000], -[2419, 0.37250, 0.07361, 0.00000], -[2420, 0.40250, 0.03897, 0.00000], -[2421, 0.41500, 0.02598, 0.00000], -[2422, 0.43750, 0.00433, 0.00000], -[2423, 0.39000, 0.05196, 0.00000], -[2424, 0.37500, 0.06928, 0.00000], -[2425, 0.42750, 0.01299, 0.00000], -[2426, 0.40500, 0.03464, 0.00000], -[2427, 0.36000, 0.08660, 0.00000], -[2428, 0.21500, 0.50800, 0.00000], -[2429, 0.35500, 0.09300, 0.00000], -[2430, 0.37750, 0.06495, 0.00000], -[2431, 0.41750, 0.02165, 0.00000], -[2432, 0.39250, 0.04763, 0.00000], -[2433, 0.44000, 0.00000, 0.00000], -[2434, 0.36250, 0.08227, 0.00000], -[2435, 0.43000, 0.00866, 0.00000], -[2436, 0.38000, 0.06062, 0.00000], -[2437, 0.40750, 0.03031, 0.00000], -[2438, 0.39500, 0.04330, 0.00000], -[2439, 0.42000, 0.01732, 0.00000], -[2440, 0.36500, 0.07794, 0.00000], -[2441, 0.38250, 0.05629, 0.00000], -[2442, 0.43250, 0.00433, 0.00000], -[2443, 0.36750, 0.07361, 0.00000], -[2444, 0.41000, 0.02598, 0.00000], -[2445, 0.39750, 0.03897, 0.00000], -[2446, 0.42250, 0.01299, 0.00000], -[2447, 0.38500, 0.05196, 0.00000], -[2448, 0.37000, 0.06928, 0.00000], -[2449, 0.40000, 0.03464, 0.00000], -[2450, 0.41250, 0.02165, 0.00000], -[2451, 0.43500, 0.00000, 0.00000], -[2452, 0.37250, 0.06495, 0.00000], -[2453, 0.38750, 0.04763, 0.00000], -[2454, 0.35500, 0.08660, 0.00000], -[2455, 0.35000, 0.09300, 0.00000], -[2456, 0.42500, 0.00866, 0.00000], -[2457, 0.35750, 0.08227, 0.00000], -[2458, 0.40250, 0.03031, 0.00000], -[2459, 0.37500, 0.06062, 0.00000], -[2460, 0.41500, 0.01732, 0.00000], -[2461, 0.39000, 0.04330, 0.00000], -[2462, 0.21000, 0.50800, 0.00000], -[2463, 0.36000, 0.07794, 0.00000], -[2464, 0.42750, 0.00433, 0.00000], -[2465, 0.37750, 0.05629, 0.00000], -[2466, 0.40500, 0.02598, 0.00000], -[2467, 0.39250, 0.03897, 0.00000], -[2468, 0.36250, 0.07361, 0.00000], -[2469, 0.41750, 0.01299, 0.00000], -[2470, 0.38000, 0.05196, 0.00000], -[2471, 0.36500, 0.06928, 0.00000], -[2472, 0.43000, 0.00000, 0.00000], -[2473, 0.40750, 0.02165, 0.00000], -[2474, 0.39500, 0.03464, 0.00000], -[2475, 0.42000, 0.00866, 0.00000], -[2476, 0.38250, 0.04763, 0.00000], -[2477, 0.36750, 0.06495, 0.00000], -[2478, 0.35000, 0.08660, 0.00000], -[2479, 0.34500, 0.09300, 0.00000], -[2480, 0.39750, 0.03031, 0.00000], -[2481, 0.41000, 0.01732, 0.00000], -[2482, 0.35250, 0.08227, 0.00000], -[2483, 0.37000, 0.06062, 0.00000], -[2484, 0.38500, 0.04330, 0.00000], -[2485, 0.42250, 0.00433, 0.00000], -[2486, 0.35500, 0.07794, 0.00000], -[2487, 0.37250, 0.05629, 0.00000], -[2488, 0.40000, 0.02598, 0.00000], -[2489, 0.38750, 0.03897, 0.00000], -[2490, 0.41250, 0.01299, 0.00000], -[2491, 0.35750, 0.07361, 0.00000], -[2492, 0.20500, 0.50800, 0.00000], -[2493, 0.37500, 0.05196, 0.00000], -[2494, 0.42500, 0.00000, 0.00000], -[2495, 0.40250, 0.02165, 0.00000], -[2496, 0.36000, 0.06928, 0.00000], -[2497, 0.39000, 0.03464, 0.00000], -[2498, 0.41500, 0.00866, 0.00000], -[2499, 0.37750, 0.04763, 0.00000], -[2500, 0.36250, 0.06495, 0.00000], -[2501, 0.34500, 0.08660, 0.00000], -[2502, 0.39250, 0.03031, 0.00000], -[2503, 0.40500, 0.01732, 0.00000], -[2504, 0.34000, 0.09300, 0.00000], -[2505, 0.38000, 0.04330, 0.00000], -[2506, 0.36500, 0.06062, 0.00000], -[2507, 0.41750, 0.00433, 0.00000], -[2508, 0.34750, 0.08227, 0.00000], -[2509, 0.39500, 0.02598, 0.00000], -[2510, 0.35000, 0.07794, 0.00000], -[2511, 0.40750, 0.01299, 0.00000], -[2512, 0.36750, 0.05629, 0.00000], -[2513, 0.38250, 0.03897, 0.00000], -[2514, 0.35250, 0.07361, 0.00000], -[2515, 0.42000, 0.00000, 0.00000], -[2516, 0.37000, 0.05196, 0.00000], -[2517, 0.39750, 0.02165, 0.00000], -[2518, 0.38500, 0.03464, 0.00000], -[2519, 0.41000, 0.00866, 0.00000], -[2520, 0.35500, 0.06928, 0.00000], -[2521, 0.34000, 0.08811, 0.00000], -[2522, 0.20000, 0.50800, 0.00000], -[2523, 0.37250, 0.04763, 0.00000], -[2524, 0.35750, 0.06495, 0.00000], -[2525, 0.40000, 0.01732, 0.00000], -[2526, 0.38750, 0.03031, 0.00000], -[2527, 0.41250, 0.00433, 0.00000], -[2528, 0.33500, 0.09300, 0.00000], -[2529, 0.37500, 0.04330, 0.00000], -[2530, 0.36000, 0.06062, 0.00000], -[2531, 0.34250, 0.08227, 0.00000], -[2532, 0.39000, 0.02598, 0.00000], -[2533, 0.40250, 0.01299, 0.00000], -[2534, 0.36250, 0.05629, 0.00000], -[2535, 0.34500, 0.07794, 0.00000], -[2536, 0.37750, 0.03897, 0.00000], -[2537, 0.41500, 0.00000, 0.00000], -[2538, 0.34750, 0.07361, 0.00000], -[2539, 0.39250, 0.02165, 0.00000], -[2540, 0.36500, 0.05196, 0.00000], -[2541, 0.40500, 0.00866, 0.00000], -[2542, 0.38000, 0.03464, 0.00000], -[2543, 0.35000, 0.06928, 0.00000], -[2544, 0.36750, 0.04763, 0.00000], -[2545, 0.39500, 0.01732, 0.00000], -[2546, 0.38250, 0.03031, 0.00000], -[2547, 0.35250, 0.06495, 0.00000], -[2548, 0.40750, 0.00433, 0.00000], -[2549, 0.33500, 0.08660, 0.00000], -[2550, 0.37000, 0.04330, 0.00000], -[2551, 0.19500, 0.50800, 0.00000], -[2552, 0.33000, 0.09300, 0.00000], -[2553, 0.35500, 0.06062, 0.00000], -[2554, 0.39750, 0.01299, 0.00000], -[2555, 0.38500, 0.02598, 0.00000], -[2556, 0.33750, 0.08227, 0.00000], -[2557, 0.41000, 0.00000, 0.00000], -[2558, 0.37250, 0.03897, 0.00000], -[2559, 0.35750, 0.05629, 0.00000], -[2560, 0.34000, 0.07794, 0.00000], -[2561, 0.38750, 0.02165, 0.00000], -[2562, 0.40000, 0.00866, 0.00000], -[2563, 0.34250, 0.07361, 0.00000], -[2564, 0.36000, 0.05196, 0.00000], -[2565, 0.37500, 0.03464, 0.00000], -[2566, 0.34500, 0.06928, 0.00000], -[2567, 0.36250, 0.04763, 0.00000], -[2568, 0.39000, 0.01732, 0.00000], -[2569, 0.40250, 0.00433, 0.00000], -[2570, 0.37750, 0.03031, 0.00000], -[2571, 0.34750, 0.06495, 0.00000], -[2572, 0.36500, 0.04330, 0.00000], -[2573, 0.33000, 0.08660, 0.00000], -[2574, 0.39250, 0.01299, 0.00000], -[2575, 0.35000, 0.06062, 0.00000], -[2576, 0.38000, 0.02598, 0.00000], -[2577, 0.32500, 0.09300, 0.00000], -[2578, 0.40500, 0.00000, 0.00000], -[2579, 0.33250, 0.08227, 0.00000], -[2580, 0.36750, 0.03897, 0.00000], -[2581, 0.35250, 0.05629, 0.00000], -[2582, 0.19000, 0.50800, 0.00000], -[2583, 0.33500, 0.07794, 0.00000], -[2584, 0.38250, 0.02165, 0.00000], -[2585, 0.39500, 0.00866, 0.00000], -[2586, 0.37000, 0.03464, 0.00000], -[2587, 0.35500, 0.05196, 0.00000], -[2588, 0.33750, 0.07361, 0.00000], -[2589, 0.38500, 0.01732, 0.00000], -[2590, 0.34000, 0.06928, 0.00000], -[2591, 0.39750, 0.00433, 0.00000], -[2592, 0.35750, 0.04763, 0.00000], -[2593, 0.37250, 0.03031, 0.00000], -[2594, 0.34250, 0.06495, 0.00000], -[2595, 0.36000, 0.04330, 0.00000], -[2596, 0.38750, 0.01299, 0.00000], -[2597, 0.37500, 0.02598, 0.00000], -[2598, 0.40000, 0.00000, 0.00000], -[2599, 0.34500, 0.06062, 0.00000], -[2600, 0.32500, 0.08660, 0.00000], -[2601, 0.32000, 0.09300, 0.00000], -[2602, 0.36250, 0.03897, 0.00000], -[2603, 0.32750, 0.08227, 0.00000], -[2604, 0.34750, 0.05629, 0.00000], -[2605, 0.39000, 0.00866, 0.00000], -[2606, 0.37750, 0.02165, 0.00000], -[2607, 0.33000, 0.07794, 0.00000], -[2608, 0.36500, 0.03464, 0.00000], -[2609, 0.35000, 0.05196, 0.00000], -[2610, 0.33250, 0.07361, 0.00000], -[2611, 0.38000, 0.01732, 0.00000], -[2612, 0.18500, 0.50800, 0.00000], -[2613, 0.39250, 0.00433, 0.00000], -[2614, 0.35250, 0.04763, 0.00000], -[2615, 0.33500, 0.06928, 0.00000], -[2616, 0.36750, 0.03031, 0.00000], -[2617, 0.33750, 0.06495, 0.00000], -[2618, 0.38250, 0.01299, 0.00000], -[2619, 0.35500, 0.04330, 0.00000], -[2620, 0.39500, 0.00000, 0.00000], -[2621, 0.37000, 0.02598, 0.00000], -[2622, 0.34000, 0.06062, 0.00000], -[2623, 0.32000, 0.08660, 0.00000], -[2624, 0.35750, 0.03897, 0.00000], -[2625, 0.31500, 0.09300, 0.00000], -[2626, 0.38500, 0.00866, 0.00000], -[2627, 0.32250, 0.08227, 0.00000], -[2628, 0.37250, 0.02165, 0.00000], -[2629, 0.34250, 0.05629, 0.00000], -[2630, 0.32500, 0.07794, 0.00000], -[2631, 0.36000, 0.03464, 0.00000], -[2632, 0.34500, 0.05196, 0.00000], -[2633, 0.38750, 0.00433, 0.00000], -[2634, 0.37500, 0.01732, 0.00000], -[2635, 0.32750, 0.07361, 0.00000], -[2636, 0.36250, 0.03031, 0.00000], -[2637, 0.34750, 0.04763, 0.00000], -[2638, 0.33000, 0.06928, 0.00000], -[2639, 0.37750, 0.01299, 0.00000], -[2640, 0.39000, 0.00000, 0.00000], -[2641, 0.33250, 0.06495, 0.00000], -[2642, 0.18000, 0.50800, 0.00000], -[2643, 0.35000, 0.04330, 0.00000], -[2644, 0.36500, 0.02598, 0.00000], -[2645, 0.31500, 0.08804, 0.00000], -[2646, 0.33500, 0.06062, 0.00000], -[2647, 0.38000, 0.00866, 0.00000], -[2648, 0.35250, 0.03897, 0.00000], -[2649, 0.36750, 0.02165, 0.00000], -[2650, 0.31000, 0.09300, 0.00000], -[2651, 0.33750, 0.05629, 0.00000], -[2652, 0.31750, 0.08227, 0.00000], -[2653, 0.35500, 0.03464, 0.00000], -[2654, 0.32000, 0.07794, 0.00000], -[2655, 0.38250, 0.00433, 0.00000], -[2656, 0.34000, 0.05196, 0.00000], -[2657, 0.37000, 0.01732, 0.00000], -[2658, 0.32250, 0.07361, 0.00000], -[2659, 0.35750, 0.03031, 0.00000], -[2660, 0.34250, 0.04763, 0.00000], -[2661, 0.32500, 0.06928, 0.00000], -[2662, 0.38500, 0.00000, 0.00000], -[2663, 0.37250, 0.01299, 0.00000], -[2664, 0.36000, 0.02598, 0.00000], -[2665, 0.34500, 0.04330, 0.00000], -[2666, 0.32750, 0.06495, 0.00000], -[2667, 0.37500, 0.00866, 0.00000], -[2668, 0.33000, 0.06062, 0.00000], -[2669, 0.34750, 0.03897, 0.00000], -[2670, 0.36250, 0.02165, 0.00000], -[2671, 0.17500, 0.50800, 0.00000], -[2672, 0.31000, 0.08644, 0.00000], -[2673, 0.33250, 0.05629, 0.00000], -[2674, 0.30500, 0.09300, 0.00000], -[2675, 0.31250, 0.08227, 0.00000], -[2676, 0.35000, 0.03464, 0.00000], -[2677, 0.37750, 0.00433, 0.00000], -[2678, 0.36500, 0.01732, 0.00000], -[2679, 0.31500, 0.07794, 0.00000], -[2680, 0.33500, 0.05196, 0.00000], -[2681, 0.35250, 0.03031, 0.00000], -[2682, 0.31750, 0.07361, 0.00000], -[2683, 0.33750, 0.04763, 0.00000], -[2684, 0.38000, 0.00000, 0.00000], -[2685, 0.36750, 0.01299, 0.00000], -[2686, 0.32000, 0.06928, 0.00000], -[2687, 0.35500, 0.02598, 0.00000], -[2688, 0.34000, 0.04330, 0.00000], -[2689, 0.32250, 0.06495, 0.00000], -[2690, 0.37000, 0.00866, 0.00000], -[2691, 0.32500, 0.06062, 0.00000], -[2692, 0.34250, 0.03897, 0.00000], -[2693, 0.35750, 0.02165, 0.00000], -[2694, 0.30500, 0.08660, 0.00000], -[2695, 0.32750, 0.05629, 0.00000], -[2696, 0.37250, 0.00433, 0.00000], -[2697, 0.34500, 0.03464, 0.00000], -[2698, 0.30000, 0.09300, 0.00000], -[2699, 0.30750, 0.08227, 0.00000], -[2700, 0.36000, 0.01732, 0.00000], -[2701, 0.33000, 0.05196, 0.00000], -[2702, 0.17000, 0.50800, 0.00000], -[2703, 0.31000, 0.07794, 0.00000], -[2704, 0.34750, 0.03031, 0.00000], -[2705, 0.37500, 0.00000, 0.00000], -[2706, 0.31250, 0.07361, 0.00000], -[2707, 0.36250, 0.01299, 0.00000], -[2708, 0.33250, 0.04763, 0.00000], -[2709, 0.31500, 0.06928, 0.00000], -[2710, 0.35000, 0.02598, 0.00000], -[2711, 0.33500, 0.04330, 0.00000], -[2712, 0.36500, 0.00866, 0.00000], -[2713, 0.31750, 0.06495, 0.00000], -[2714, 0.35250, 0.02165, 0.00000], -[2715, 0.33750, 0.03897, 0.00000], -[2716, 0.32000, 0.06062, 0.00000], -[2717, 0.36750, 0.00433, 0.00000], -[2718, 0.32250, 0.05629, 0.00000], -[2719, 0.30000, 0.08660, 0.00000], -[2720, 0.34000, 0.03464, 0.00000], -[2721, 0.35500, 0.01732, 0.00000], -[2722, 0.29500, 0.09300, 0.00000], -[2723, 0.30250, 0.08227, 0.00000], -[2724, 0.32500, 0.05196, 0.00000], -[2725, 0.37000, 0.00000, 0.00000], -[2726, 0.30500, 0.07794, 0.00000], -[2727, 0.34250, 0.03031, 0.00000], -[2728, 0.35750, 0.01299, 0.00000], -[2729, 0.32750, 0.04763, 0.00000], -[2730, 0.30750, 0.07361, 0.00000], -[2731, 0.16500, 0.50800, 0.00000], -[2732, 0.34500, 0.02598, 0.00000], -[2733, 0.31000, 0.06928, 0.00000], -[2734, 0.33000, 0.04330, 0.00000], -[2735, 0.36000, 0.00866, 0.00000], -[2736, 0.31250, 0.06495, 0.00000], -[2737, 0.34750, 0.02165, 0.00000], -[2738, 0.33250, 0.03897, 0.00000], -[2739, 0.31500, 0.06062, 0.00000], -[2740, 0.36250, 0.00433, 0.00000], -[2741, 0.35000, 0.01732, 0.00000], -[2742, 0.33500, 0.03464, 0.00000], -[2743, 0.31750, 0.05629, 0.00000], -[2744, 0.29500, 0.08660, 0.00000], -[2745, 0.29750, 0.08227, 0.00000], -[2746, 0.36500, 0.00000, 0.00000], -[2747, 0.29000, 0.09300, 0.00000], -[2748, 0.32000, 0.05196, 0.00000], -[2749, 0.33750, 0.03031, 0.00000], -[2750, 0.35250, 0.01299, 0.00000], -[2751, 0.30000, 0.07794, 0.00000], -[2752, 0.32250, 0.04763, 0.00000], -[2753, 0.30250, 0.07361, 0.00000], -[2754, 0.34000, 0.02598, 0.00000], -[2755, 0.35500, 0.00866, 0.00000], -[2756, 0.30500, 0.06928, 0.00000], -[2757, 0.32500, 0.04330, 0.00000], -[2758, 0.34250, 0.02165, 0.00000], -[2759, 0.30750, 0.06495, 0.00000], -[2760, 0.16000, 0.50800, 0.00000], -[2761, 0.32750, 0.03897, 0.00000], -[2762, 0.35750, 0.00433, 0.00000], -[2763, 0.31000, 0.06062, 0.00000], -[2764, 0.34500, 0.01732, 0.00000], -[2765, 0.33000, 0.03464, 0.00000], -[2766, 0.31250, 0.05629, 0.00000], -[2767, 0.36000, 0.00000, 0.00000], -[2768, 0.29000, 0.08660, 0.00000], -[2769, 0.31500, 0.05196, 0.00000], -[2770, 0.33250, 0.03031, 0.00000], -[2771, 0.34750, 0.01299, 0.00000], -[2772, 0.29250, 0.08227, 0.00000], -[2773, 0.28500, 0.09300, 0.00000], -[2774, 0.29500, 0.07794, 0.00000], -[2775, 0.31750, 0.04763, 0.00000], -[2776, 0.33500, 0.02598, 0.00000], -[2777, 0.29750, 0.07361, 0.00000], -[2778, 0.35000, 0.00866, 0.00000], -[2779, 0.32000, 0.04330, 0.00000], -[2780, 0.30000, 0.06928, 0.00000], -[2781, 0.33750, 0.02165, 0.00000], -[2782, 0.30250, 0.06495, 0.00000], -[2783, 0.35250, 0.00433, 0.00000], -[2784, 0.32250, 0.03897, 0.00000], -[2785, 0.30500, 0.06062, 0.00000], -[2786, 0.34000, 0.01732, 0.00000], -[2787, 0.32500, 0.03464, 0.00000], -[2788, 0.15500, 0.50800, 0.00000], -[2789, 0.35500, 0.00000, 0.00000], -[2790, 0.30750, 0.05629, 0.00000], -[2791, 0.28500, 0.08660, 0.00000], -[2792, 0.34250, 0.01299, 0.00000], -[2793, 0.32750, 0.03031, 0.00000], -[2794, 0.31000, 0.05196, 0.00000], -[2795, 0.28750, 0.08227, 0.00000], -[2796, 0.28000, 0.09300, 0.00000], -[2797, 0.29000, 0.07794, 0.00000], -[2798, 0.31250, 0.04763, 0.00000], -[2799, 0.33000, 0.02598, 0.00000], -[2800, 0.34500, 0.00866, 0.00000], -[2801, 0.29250, 0.07361, 0.00000], -[2802, 0.31500, 0.04330, 0.00000], -[2803, 0.29500, 0.06928, 0.00000], -[2804, 0.33250, 0.02165, 0.00000], -[2805, 0.34750, 0.00433, 0.00000], -[2806, 0.31750, 0.03897, 0.00000], -[2807, 0.29750, 0.06495, 0.00000], -[2808, 0.33500, 0.01732, 0.00000], -[2809, 0.30000, 0.06062, 0.00000], -[2810, 0.32000, 0.03464, 0.00000], -[2811, 0.35000, 0.00000, 0.00000], -[2812, 0.30250, 0.05629, 0.00000], -[2813, 0.33750, 0.01299, 0.00000], -[2814, 0.32250, 0.03031, 0.00000], -[2815, 0.28000, 0.08660, 0.00000], -[2816, 0.30500, 0.05196, 0.00000], -[2817, 0.15000, 0.50800, 0.00000], -[2818, 0.28250, 0.08227, 0.00000], -[2819, 0.27500, 0.09300, 0.00000], -[2820, 0.34000, 0.00866, 0.00000], -[2821, 0.32500, 0.02598, 0.00000], -[2822, 0.30750, 0.04763, 0.00000], -[2823, 0.28500, 0.07794, 0.00000], -[2824, 0.28750, 0.07361, 0.00000], -[2825, 0.31000, 0.04330, 0.00000], -[2826, 0.32750, 0.02165, 0.00000], -[2827, 0.34250, 0.00433, 0.00000], -[2828, 0.29000, 0.06928, 0.00000], -[2829, 0.31250, 0.03897, 0.00000], -[2830, 0.29250, 0.06495, 0.00000], -[2831, 0.33000, 0.01732, 0.00000], -[2832, 0.34500, 0.00000, 0.00000], -[2833, 0.29500, 0.06062, 0.00000], -[2834, 0.31500, 0.03464, 0.00000], -[2835, 0.29750, 0.05629, 0.00000], -[2836, 0.33250, 0.01299, 0.00000], -[2837, 0.31750, 0.03031, 0.00000], -[2838, 0.30000, 0.05196, 0.00000], -[2839, 0.27500, 0.08660, 0.00000], -[2840, 0.33500, 0.00866, 0.00000], -[2841, 0.32000, 0.02598, 0.00000], -[2842, 0.27750, 0.08227, 0.00000], -[2843, 0.30250, 0.04763, 0.00000], -[2844, 0.27000, 0.09300, 0.00000], -[2845, 0.28000, 0.07794, 0.00000], -[2846, 0.30500, 0.04330, 0.00000], -[2847, 0.28250, 0.07361, 0.00000], -[2848, 0.14500, 0.50800, 0.00000], -[2849, 0.32250, 0.02165, 0.00000], -[2850, 0.33750, 0.00433, 0.00000], -[2851, 0.28500, 0.06928, 0.00000], -[2852, 0.30750, 0.03897, 0.00000], -[2853, 0.32500, 0.01732, 0.00000], -[2854, 0.28750, 0.06495, 0.00000], -[2855, 0.34000, 0.00000, 0.00000], -[2856, 0.31000, 0.03464, 0.00000], -[2857, 0.29000, 0.06062, 0.00000], -[2858, 0.32750, 0.01299, 0.00000], -[2859, 0.29250, 0.05629, 0.00000], -[2860, 0.31250, 0.03031, 0.00000], -[2861, 0.29500, 0.05196, 0.00000], -[2862, 0.33000, 0.00866, 0.00000], -[2863, 0.27000, 0.08660, 0.00000], -[2864, 0.31500, 0.02598, 0.00000], -[2865, 0.29750, 0.04763, 0.00000], -[2866, 0.27250, 0.08227, 0.00000], -[2867, 0.26500, 0.09300, 0.00000], -[2868, 0.27500, 0.07794, 0.00000], -[2869, 0.33250, 0.00433, 0.00000], -[2870, 0.31750, 0.02165, 0.00000], -[2871, 0.30000, 0.04330, 0.00000], -[2872, 0.27750, 0.07361, 0.00000], -[2873, 0.28000, 0.06928, 0.00000], -[2874, 0.30250, 0.03897, 0.00000], -[2875, 0.32000, 0.01732, 0.00000], -[2876, 0.33500, 0.00000, 0.00000], -[2877, 0.28250, 0.06495, 0.00000], -[2878, 0.14000, 0.50800, 0.00000], -[2879, 0.30500, 0.03464, 0.00000], -[2880, 0.28500, 0.06062, 0.00000], -[2881, 0.32250, 0.01299, 0.00000], -[2882, 0.28750, 0.05629, 0.00000], -[2883, 0.30750, 0.03031, 0.00000], -[2884, 0.26500, 0.08811, 0.00000], -[2885, 0.32500, 0.00866, 0.00000], -[2886, 0.29000, 0.05196, 0.00000], -[2887, 0.31000, 0.02598, 0.00000], -[2888, 0.29250, 0.04763, 0.00000], -[2889, 0.26750, 0.08227, 0.00000], -[2890, 0.32750, 0.00433, 0.00000], -[2891, 0.31250, 0.02165, 0.00000], -[2892, 0.26000, 0.09300, 0.00000], -[2893, 0.27000, 0.07794, 0.00000], -[2894, 0.29500, 0.04330, 0.00000], -[2895, 0.27250, 0.07361, 0.00000], -[2896, 0.33000, 0.00000, 0.00000], -[2897, 0.31500, 0.01732, 0.00000], -[2898, 0.29750, 0.03897, 0.00000], -[2899, 0.27500, 0.06928, 0.00000], -[2900, 0.27750, 0.06495, 0.00000], -[2901, 0.30000, 0.03464, 0.00000], -[2902, 0.31750, 0.01299, 0.00000], -[2903, 0.28000, 0.06062, 0.00000], -[2904, 0.30250, 0.03031, 0.00000], -[2905, 0.13500, 0.50800, 0.00000], -[2906, 0.28250, 0.05629, 0.00000], -[2907, 0.32000, 0.00866, 0.00000], -[2908, 0.28500, 0.05196, 0.00000], -[2909, 0.30500, 0.02598, 0.00000], -[2910, 0.28750, 0.04763, 0.00000], -[2911, 0.26000, 0.08660, 0.00000], -[2912, 0.32250, 0.00433, 0.00000], -[2913, 0.30750, 0.02165, 0.00000], -[2914, 0.26250, 0.08227, 0.00000], -[2915, 0.29000, 0.04330, 0.00000], -[2916, 0.26500, 0.07794, 0.00000], -[2917, 0.25500, 0.09300, 0.00000], -[2918, 0.32500, 0.00000, 0.00000], -[2919, 0.26750, 0.07361, 0.00000], -[2920, 0.31000, 0.01732, 0.00000], -[2921, 0.29250, 0.03897, 0.00000], -[2922, 0.27000, 0.06928, 0.00000], -[2923, 0.27250, 0.06495, 0.00000], -[2924, 0.29500, 0.03464, 0.00000], -[2925, 0.31250, 0.01299, 0.00000], -[2926, 0.27500, 0.06062, 0.00000], -[2927, 0.29750, 0.03031, 0.00000], -[2928, 0.27750, 0.05629, 0.00000], -[2929, 0.31500, 0.00866, 0.00000], -[2930, 0.30000, 0.02598, 0.00000], -[2931, 0.28000, 0.05196, 0.00000], -[2932, 0.13000, 0.50800, 0.00000], -[2933, 0.31750, 0.00433, 0.00000], -[2934, 0.28250, 0.04763, 0.00000], -[2935, 0.30250, 0.02165, 0.00000], -[2936, 0.25500, 0.08660, 0.00000], -[2937, 0.25750, 0.08227, 0.00000], -[2938, 0.28500, 0.04330, 0.00000], -[2939, 0.32000, 0.00000, 0.00000], -[2940, 0.26000, 0.07794, 0.00000], -[2941, 0.25000, 0.09300, 0.00000], -[2942, 0.30500, 0.01732, 0.00000], -[2943, 0.26250, 0.07361, 0.00000], -[2944, 0.28750, 0.03897, 0.00000], -[2945, 0.26500, 0.06928, 0.00000], -[2946, 0.30750, 0.01299, 0.00000], -[2947, 0.29000, 0.03464, 0.00000], -[2948, 0.26750, 0.06495, 0.00000], -[2949, 0.27000, 0.06062, 0.00000], -[2950, 0.29250, 0.03031, 0.00000], -[2951, 0.31000, 0.00866, 0.00000], -[2952, 0.27250, 0.05629, 0.00000], -[2953, 0.29500, 0.02598, 0.00000], -[2954, 0.27500, 0.05196, 0.00000], -[2955, 0.31250, 0.00433, 0.00000], -[2956, 0.27750, 0.04763, 0.00000], -[2957, 0.29750, 0.02165, 0.00000], -[2958, 0.25000, 0.08660, 0.00000], -[2959, 0.31500, 0.00000, 0.00000], -[2960, 0.28000, 0.04330, 0.00000], -[2961, 0.25250, 0.08227, 0.00000], -[2962, 0.12500, 0.50800, 0.00000], -[2963, 0.30000, 0.01732, 0.00000], -[2964, 0.25500, 0.07794, 0.00000], -[2965, 0.24500, 0.09300, 0.00000], -[2966, 0.28250, 0.03897, 0.00000], -[2967, 0.25750, 0.07361, 0.00000], -[2968, 0.30250, 0.01299, 0.00000], -[2969, 0.26000, 0.06928, 0.00000], -[2970, 0.28500, 0.03464, 0.00000], -[2971, 0.26250, 0.06495, 0.00000], -[2972, 0.28750, 0.03031, 0.00000], -[2973, 0.30500, 0.00866, 0.00000], -[2974, 0.26500, 0.06062, 0.00000], -[2975, 0.26750, 0.05629, 0.00000], -[2976, 0.29000, 0.02598, 0.00000], -[2977, 0.30750, 0.00433, 0.00000], -[2978, 0.27000, 0.05196, 0.00000], -[2979, 0.29250, 0.02165, 0.00000], -[2980, 0.27250, 0.04763, 0.00000], -[2981, 0.31000, 0.00000, 0.00000], -[2982, 0.27500, 0.04330, 0.00000], -[2983, 0.24500, 0.08660, 0.00000], -[2984, 0.29500, 0.01732, 0.00000], -[2985, 0.24750, 0.08227, 0.00000], -[2986, 0.25000, 0.07794, 0.00000], -[2987, 0.27750, 0.03897, 0.00000], -[2988, 0.24000, 0.09300, 0.00000], -[2989, 0.25250, 0.07361, 0.00000], -[2990, 0.29750, 0.01299, 0.00000], -[2991, 0.12000, 0.50800, 0.00000], -[2992, 0.28000, 0.03464, 0.00000], -[2993, 0.25500, 0.06928, 0.00000], -[2994, 0.25750, 0.06495, 0.00000], -[2995, 0.30000, 0.00866, 0.00000], -[2996, 0.28250, 0.03031, 0.00000], -[2997, 0.26000, 0.06062, 0.00000], -[2998, 0.26250, 0.05629, 0.00000], -[2999, 0.28500, 0.02598, 0.00000], -[3000, 0.30250, 0.00433, 0.00000], -[3001, 0.26500, 0.05196, 0.00000], -[3002, 0.28750, 0.02165, 0.00000], -[3003, 0.26750, 0.04763, 0.00000], -[3004, 0.30500, 0.00000, 0.00000], -[3005, 0.27000, 0.04330, 0.00000], -[3006, 0.29000, 0.01732, 0.00000], -[3007, 0.24000, 0.08660, 0.00000], -[3008, 0.24250, 0.08227, 0.00000], -[3009, 0.27250, 0.03897, 0.00000], -[3010, 0.24500, 0.07794, 0.00000], -[3011, 0.29250, 0.01299, 0.00000], -[3012, 0.24750, 0.07361, 0.00000], -[3013, 0.23500, 0.09300, 0.00000], -[3014, 0.27500, 0.03464, 0.00000], -[3015, 0.25000, 0.06928, 0.00000], -[3016, 0.29500, 0.00866, 0.00000], -[3017, 0.25250, 0.06495, 0.00000], -[3018, 0.27750, 0.03031, 0.00000], -[3019, 0.25500, 0.06062, 0.00000], -[3020, 0.11500, 0.50800, 0.00000], -[3021, 0.29750, 0.00433, 0.00000], -[3022, 0.28000, 0.02598, 0.00000], -[3023, 0.25750, 0.05629, 0.00000], -[3024, 0.26000, 0.05196, 0.00000], -[3025, 0.28250, 0.02165, 0.00000], -[3026, 0.30000, 0.00000, 0.00000], -[3027, 0.26250, 0.04763, 0.00000], -[3028, 0.28500, 0.01732, 0.00000], -[3029, 0.26500, 0.04330, 0.00000], -[3030, 0.23500, 0.08660, 0.00000], -[3031, 0.26750, 0.03897, 0.00000], -[3032, 0.23750, 0.08227, 0.00000], -[3033, 0.28750, 0.01299, 0.00000], -[3034, 0.24000, 0.07794, 0.00000], -[3035, 0.27000, 0.03464, 0.00000], -[3036, 0.24250, 0.07361, 0.00000], -[3037, 0.23000, 0.09300, 0.00000], -[3038, 0.29000, 0.00866, 0.00000], -[3039, 0.24500, 0.06928, 0.00000], -[3040, 0.27250, 0.03031, 0.00000], -[3041, 0.24750, 0.06495, 0.00000], -[3042, 0.25000, 0.06062, 0.00000], -[3043, 0.29250, 0.00433, 0.00000], -[3044, 0.27500, 0.02598, 0.00000], -[3045, 0.25250, 0.05629, 0.00000], -[3046, 0.25500, 0.05196, 0.00000], -[3047, 0.27750, 0.02165, 0.00000], -[3048, 0.29500, 0.00000, 0.00000], -[3049, 0.11000, 0.50800, 0.00000], -[3050, 0.25750, 0.04763, 0.00000], -[3051, 0.28000, 0.01732, 0.00000], -[3052, 0.26000, 0.04330, 0.00000], -[3053, 0.28250, 0.01299, 0.00000], -[3054, 0.26250, 0.03897, 0.00000], -[3055, 0.23000, 0.08660, 0.00000], -[3056, 0.23250, 0.08227, 0.00000], -[3057, 0.23500, 0.07794, 0.00000], -[3058, 0.26500, 0.03464, 0.00000], -[3059, 0.28500, 0.00866, 0.00000], -[3060, 0.23750, 0.07361, 0.00000], -[3061, 0.22500, 0.09300, 0.00000], -[3062, 0.24000, 0.06928, 0.00000], -[3063, 0.26750, 0.03031, 0.00000], -[3064, 0.24250, 0.06495, 0.00000], -[3065, 0.28750, 0.00433, 0.00000], -[3066, 0.24500, 0.06062, 0.00000], -[3067, 0.27000, 0.02598, 0.00000], -[3068, 0.24750, 0.05629, 0.00000], -[3069, 0.29000, 0.00000, 0.00000], -[3070, 0.27250, 0.02165, 0.00000], -[3071, 0.25000, 0.05196, 0.00000], -[3072, 0.25250, 0.04763, 0.00000], -[3073, 0.27500, 0.01732, 0.00000], -[3074, 0.25500, 0.04330, 0.00000], -[3075, 0.10500, 0.50800, 0.00000], -[3076, 0.27750, 0.01299, 0.00000], -[3077, 0.25750, 0.03897, 0.00000], -[3078, 0.22500, 0.08660, 0.00000], -[3079, 0.22750, 0.08227, 0.00000], -[3080, 0.26000, 0.03464, 0.00000], -[3081, 0.28000, 0.00866, 0.00000], -[3082, 0.23000, 0.07794, 0.00000], -[3083, 0.23250, 0.07361, 0.00000], -[3084, 0.26250, 0.03031, 0.00000], -[3085, 0.22000, 0.09300, 0.00000], -[3086, 0.23500, 0.06928, 0.00000], -[3087, 0.28250, 0.00433, 0.00000], -[3088, 0.23750, 0.06495, 0.00000], -[3089, 0.26500, 0.02598, 0.00000], -[3090, 0.24000, 0.06062, 0.00000], -[3091, 0.28500, 0.00000, 0.00000], -[3092, 0.24250, 0.05629, 0.00000], -[3093, 0.26750, 0.02165, 0.00000], -[3094, 0.24500, 0.05196, 0.00000], -[3095, 0.27000, 0.01732, 0.00000], -[3096, 0.24750, 0.04763, 0.00000], -[3097, 0.25000, 0.04330, 0.00000], -[3098, 0.27250, 0.01299, 0.00000], -[3099, 0.21985, 0.08823, 0.00000], -[3100, 0.25250, 0.03897, 0.00000], -[3101, 0.27500, 0.00866, 0.00000], -[3102, 0.10000, 0.50800, 0.00000], -[3103, 0.25500, 0.03464, 0.00000], -[3104, 0.22250, 0.08227, 0.00000], -[3105, 0.22500, 0.07794, 0.00000], -[3106, 0.22750, 0.07361, 0.00000], -[3107, 0.25750, 0.03031, 0.00000], -[3108, 0.27750, 0.00433, 0.00000], -[3109, 0.23000, 0.06928, 0.00000], -[3110, 0.21500, 0.09300, 0.00000], -[3111, 0.23250, 0.06495, 0.00000], -[3112, 0.26000, 0.02598, 0.00000], -[3113, 0.23500, 0.06062, 0.00000], -[3114, 0.28000, 0.00000, 0.00000], -[3115, 0.26250, 0.02165, 0.00000], -[3116, 0.23750, 0.05629, 0.00000], -[3117, 0.24000, 0.05196, 0.00000], -[3118, 0.26500, 0.01732, 0.00000], -[3119, 0.24250, 0.04763, 0.00000], -[3120, 0.24500, 0.04330, 0.00000], -[3121, 0.26750, 0.01299, 0.00000], -[3122, 0.24750, 0.03897, 0.00000], -[3123, 0.27000, 0.00866, 0.00000], -[3124, 0.25000, 0.03464, 0.00000], -[3125, 0.21750, 0.08227, 0.00000], -[3126, 0.21393, 0.08774, 0.00000], -[3127, 0.22000, 0.07794, 0.00000], -[3128, 0.27250, 0.00433, 0.00000], -[3129, 0.25250, 0.03031, 0.00000], -[3130, 0.22250, 0.07361, 0.00000], -[3131, 0.09500, 0.50800, 0.00000], -[3132, 0.22500, 0.06928, 0.00000], -[3133, 0.21000, 0.09300, 0.00000], -[3134, 0.25500, 0.02598, 0.00000], -[3135, 0.22750, 0.06495, 0.00000], -[3136, 0.27500, 0.00000, 0.00000], -[3137, 0.23000, 0.06062, 0.00000], -[3138, 0.25750, 0.02165, 0.00000], -[3139, 0.23250, 0.05629, 0.00000], -[3140, 0.23500, 0.05196, 0.00000], -[3141, 0.26000, 0.01732, 0.00000], -[3142, 0.23750, 0.04763, 0.00000], -[3143, 0.26250, 0.01299, 0.00000], -[3144, 0.24000, 0.04330, 0.00000], -[3145, 0.24250, 0.03897, 0.00000], -[3146, 0.26500, 0.00866, 0.00000], -[3147, 0.24500, 0.03464, 0.00000], -[3148, 0.26750, 0.00433, 0.00000], -[3149, 0.21250, 0.08227, 0.00000], -[3150, 0.24750, 0.03031, 0.00000], -[3151, 0.21500, 0.07794, 0.00000], -[3152, 0.21750, 0.07361, 0.00000], -[3153, 0.20875, 0.08764, 0.00000], -[3154, 0.25000, 0.02598, 0.00000], -[3155, 0.22000, 0.06928, 0.00000], -[3156, 0.27000, 0.00000, 0.00000], -[3157, 0.20500, 0.09300, 0.00000], -[3158, 0.22250, 0.06495, 0.00000], -[3159, 0.22500, 0.06062, 0.00000], -[3160, 0.25250, 0.02165, 0.00000], -[3161, 0.09000, 0.50800, 0.00000], -[3162, 0.22750, 0.05629, 0.00000], -[3163, 0.25500, 0.01732, 0.00000], -[3164, 0.23000, 0.05196, 0.00000], -[3165, 0.23250, 0.04763, 0.00000], -[3166, 0.25750, 0.01299, 0.00000], -[3167, 0.23500, 0.04330, 0.00000], -[3168, 0.23750, 0.03897, 0.00000], -[3169, 0.26000, 0.00866, 0.00000], -[3170, 0.24000, 0.03464, 0.00000], -[3171, 0.26250, 0.00433, 0.00000], -[3172, 0.24250, 0.03031, 0.00000], -[3173, 0.21000, 0.07794, 0.00000], -[3174, 0.26500, 0.00000, 0.00000], -[3175, 0.21250, 0.07361, 0.00000], -[3176, 0.24500, 0.02598, 0.00000], -[3177, 0.20652, 0.08307, 0.00000], -[3178, 0.21500, 0.06928, 0.00000], -[3179, 0.20313, 0.08815, 0.00000], -[3180, 0.21750, 0.06495, 0.00000], -[3181, 0.20000, 0.09300, 0.00000], -[3182, 0.24750, 0.02165, 0.00000], -[3183, 0.22000, 0.06062, 0.00000], -[3184, 0.22250, 0.05629, 0.00000], -[3185, 0.25000, 0.01732, 0.00000], -[3186, 0.22500, 0.05196, 0.00000], -[3187, 0.22750, 0.04763, 0.00000], -[3188, 0.08500, 0.50800, 0.00000], -[3189, 0.25250, 0.01299, 0.00000], -[3190, 0.23000, 0.04330, 0.00000], -[3191, 0.25500, 0.00866, 0.00000], -[3192, 0.23250, 0.03897, 0.00000], -[3193, 0.23500, 0.03464, 0.00000], -[3194, 0.25750, 0.00433, 0.00000], -[3195, 0.23750, 0.03031, 0.00000], -[3196, 0.26000, 0.00000, 0.00000], -[3197, 0.24000, 0.02598, 0.00000], -[3198, 0.20750, 0.07361, 0.00000], -[3199, 0.20439, 0.07842, 0.00000], -[3200, 0.21000, 0.06928, 0.00000], -[3201, 0.20100, 0.08351, 0.00000], -[3202, 0.24250, 0.02165, 0.00000], -[3203, 0.21250, 0.06495, 0.00000], -[3204, 0.19500, 0.09300, 0.00000], -[3205, 0.19750, 0.08867, 0.00000], -[3206, 0.21500, 0.06062, 0.00000], -[3207, 0.24500, 0.01732, 0.00000], -[3208, 0.21750, 0.05629, 0.00000], -[3209, 0.22000, 0.05196, 0.00000], -[3210, 0.24750, 0.01299, 0.00000], -[3211, 0.22250, 0.04763, 0.00000], -[3212, 0.22500, 0.04330, 0.00000], -[3213, 0.25000, 0.00866, 0.00000], -[3214, 0.22750, 0.03897, 0.00000], -[3215, 0.08000, 0.50800, 0.00000], -[3216, 0.25250, 0.00433, 0.00000], -[3217, 0.23000, 0.03464, 0.00000], -[3218, 0.23250, 0.03031, 0.00000], -[3219, 0.25500, 0.00000, 0.00000], -[3220, 0.23500, 0.02598, 0.00000], -[3221, 0.23750, 0.02165, 0.00000], -[3222, 0.20500, 0.06928, 0.00000], -[3223, 0.20188, 0.07403, 0.00000], -[3224, 0.20750, 0.06495, 0.00000], -[3225, 0.19848, 0.07916, 0.00000], -[3226, 0.21000, 0.06062, 0.00000], -[3227, 0.19000, 0.09300, 0.00000], -[3228, 0.24000, 0.01732, 0.00000], -[3229, 0.19250, 0.08867, 0.00000], -[3230, 0.19500, 0.08434, 0.00000], -[3231, 0.21250, 0.05629, 0.00000], -[3232, 0.21500, 0.05196, 0.00000], -[3233, 0.24250, 0.01299, 0.00000], -[3234, 0.21750, 0.04763, 0.00000], -[3235, 0.22000, 0.04330, 0.00000], -[3236, 0.24500, 0.00866, 0.00000], -[3237, 0.22250, 0.03897, 0.00000], -[3238, 0.24750, 0.00433, 0.00000], -[3239, 0.22500, 0.03464, 0.00000], -[3240, 0.22750, 0.03031, 0.00000], -[3241, 0.25000, 0.00000, 0.00000], -[3242, 0.07500, 0.50800, 0.00000], -[3243, 0.23000, 0.02598, 0.00000], -[3244, 0.23250, 0.02165, 0.00000], -[3245, 0.20250, 0.06495, 0.00000], -[3246, 0.23500, 0.01732, 0.00000], -[3247, 0.19938, 0.06951, 0.00000], -[3248, 0.20500, 0.06062, 0.00000], -[3249, 0.18500, 0.09300, 0.00000], -[3250, 0.18750, 0.08867, 0.00000], -[3251, 0.19589, 0.07469, 0.00000], -[3252, 0.19000, 0.08434, 0.00000], -[3253, 0.20750, 0.05629, 0.00000], -[3254, 0.19250, 0.08001, 0.00000], -[3255, 0.23750, 0.01299, 0.00000], -[3256, 0.21000, 0.05196, 0.00000], -[3257, 0.21250, 0.04763, 0.00000], -[3258, 0.24000, 0.00866, 0.00000], -[3259, 0.21500, 0.04330, 0.00000], -[3260, 0.21750, 0.03897, 0.00000], -[3261, 0.24250, 0.00433, 0.00000], -[3262, 0.22000, 0.03464, 0.00000], -[3263, 0.24500, 0.00000, 0.00000], -[3264, 0.22250, 0.03031, 0.00000], -[3265, 0.22500, 0.02598, 0.00000], -[3266, 0.22750, 0.02165, 0.00000], -[3267, 0.07000, 0.50800, 0.00000], -[3268, 0.23000, 0.01732, 0.00000], -[3269, 0.19750, 0.06495, 0.00000], -[3270, 0.20000, 0.06062, 0.00000], -[3271, 0.20250, 0.05629, 0.00000], -[3272, 0.23250, 0.01299, 0.00000], -[3273, 0.18000, 0.09300, 0.00000], -[3274, 0.18250, 0.08867, 0.00000], -[3275, 0.18500, 0.08434, 0.00000], -[3276, 0.18750, 0.08001, 0.00000], -[3277, 0.20500, 0.05196, 0.00000], -[3278, 0.19000, 0.07568, 0.00000], -[3279, 0.20750, 0.04763, 0.00000], -[3280, 0.23500, 0.00866, 0.00000], -[3281, 0.21000, 0.04330, 0.00000], -[3282, 0.23750, 0.00433, 0.00000], -[3283, 0.21250, 0.03897, 0.00000], -[3284, 0.19276, 0.06915, 0.00000], -[3285, 0.21500, 0.03464, 0.00000], -[3286, 0.24000, 0.00000, 0.00000], -[3287, 0.21750, 0.03031, 0.00000], -[3288, 0.22000, 0.02598, 0.00000], -[3289, 0.22250, 0.02165, 0.00000], -[3290, 0.22500, 0.01732, 0.00000], -[3291, 0.19500, 0.06062, 0.00000], -[3292, 0.06500, 0.50800, 0.00000], -[3293, 0.22750, 0.01299, 0.00000], -[3294, 0.19257, 0.06414, 0.00000], -[3295, 0.19750, 0.05629, 0.00000], -[3296, 0.17750, 0.08867, 0.00000], -[3297, 0.17500, 0.09300, 0.00000], -[3298, 0.18000, 0.08434, 0.00000], -[3299, 0.20000, 0.05196, 0.00000], -[3300, 0.18250, 0.08001, 0.00000], -[3301, 0.18500, 0.07568, 0.00000], -[3302, 0.23000, 0.00866, 0.00000], -[3303, 0.20250, 0.04763, 0.00000], -[3304, 0.20500, 0.04330, 0.00000], -[3305, 0.23250, 0.00433, 0.00000], -[3306, 0.20750, 0.03897, 0.00000], -[3307, 0.21000, 0.03464, 0.00000], -[3308, 0.23500, 0.00000, 0.00000], -[3309, 0.18648, 0.07015, 0.00000], -[3310, 0.21250, 0.03031, 0.00000], -[3311, 0.21500, 0.02598, 0.00000], -[3312, 0.21750, 0.02165, 0.00000], -[3313, 0.22000, 0.01732, 0.00000], -[3314, 0.18750, 0.06495, 0.00000], -[3315, 0.22250, 0.01299, 0.00000], -[3316, 0.19000, 0.06062, 0.00000], -[3317, 0.19250, 0.05629, 0.00000], -[3318, 0.22500, 0.00866, 0.00000], -[3319, 0.19500, 0.05196, 0.00000], -[3320, 0.17500, 0.08434, 0.00000], -[3321, 0.17000, 0.09300, 0.00000], -[3322, 0.19750, 0.04763, 0.00000], -[3323, 0.06000, 0.50800, 0.00000], -[3324, 0.22750, 0.00433, 0.00000], -[3325, 0.20000, 0.04330, 0.00000], -[3326, 0.20250, 0.03897, 0.00000], -[3327, 0.17181, 0.08810, 0.00000], -[3328, 0.23000, 0.00000, 0.00000], -[3329, 0.17664, 0.07929, 0.00000], -[3330, 0.20500, 0.03464, 0.00000], -[3331, 0.20750, 0.03031, 0.00000], -[3332, 0.21000, 0.02598, 0.00000], -[3333, 0.17854, 0.07447, 0.00000], -[3334, 0.18101, 0.07011, 0.00000], -[3335, 0.21250, 0.02165, 0.00000], -[3336, 0.21500, 0.01732, 0.00000], -[3337, 0.21750, 0.01299, 0.00000], -[3338, 0.18250, 0.06495, 0.00000], -[3339, 0.18500, 0.06062, 0.00000], -[3340, 0.18750, 0.05629, 0.00000], -[3341, 0.22000, 0.00866, 0.00000], -[3342, 0.19000, 0.05196, 0.00000], -[3343, 0.16500, 0.09300, 0.00000], -[3344, 0.19250, 0.04763, 0.00000], -[3345, 0.22250, 0.00433, 0.00000], -[3346, 0.19500, 0.04330, 0.00000], -[3347, 0.19750, 0.03897, 0.00000], -[3348, 0.22500, 0.00000, 0.00000], -[3349, 0.05500, 0.50800, 0.00000], -[3350, 0.20000, 0.03464, 0.00000], -[3351, 0.20250, 0.03031, 0.00000], -[3352, 0.16627, 0.08766, 0.00000], -[3353, 0.20500, 0.02598, 0.00000], -[3354, 0.16833, 0.08296, 0.00000], -[3355, 0.20750, 0.02165, 0.00000], -[3356, 0.17076, 0.07857, 0.00000], -[3357, 0.17301, 0.07403, 0.00000], -[3358, 0.21000, 0.01732, 0.00000], -[3359, 0.21250, 0.01299, 0.00000], -[3360, 0.17500, 0.06928, 0.00000], -[3361, 0.17750, 0.06495, 0.00000], -[3362, 0.18000, 0.06062, 0.00000], -[3363, 0.21500, 0.00866, 0.00000], -[3364, 0.18250, 0.05629, 0.00000], -[3365, 0.18500, 0.05196, 0.00000], -[3366, 0.21750, 0.00433, 0.00000], -[3367, 0.18750, 0.04763, 0.00000], -[3368, 0.16000, 0.09300, 0.00000], -[3369, 0.19000, 0.04330, 0.00000], -[3370, 0.22000, 0.00000, 0.00000], -[3371, 0.19250, 0.03897, 0.00000], -[3372, 0.19500, 0.03464, 0.00000], -[3373, 0.19750, 0.03031, 0.00000], -[3374, 0.20000, 0.02598, 0.00000], -[3375, 0.05000, 0.50800, 0.00000], -[3376, 0.16105, 0.08747, 0.00000], -[3377, 0.20250, 0.02165, 0.00000], -[3378, 0.20500, 0.01732, 0.00000], -[3379, 0.20750, 0.01299, 0.00000], -[3380, 0.16250, 0.08227, 0.00000], -[3381, 0.16500, 0.07794, 0.00000], -[3382, 0.16750, 0.07361, 0.00000], -[3383, 0.17000, 0.06928, 0.00000], -[3384, 0.21000, 0.00866, 0.00000], -[3385, 0.17250, 0.06495, 0.00000], -[3386, 0.17500, 0.06062, 0.00000], -[3387, 0.17750, 0.05629, 0.00000], -[3388, 0.21250, 0.00433, 0.00000], -[3389, 0.18000, 0.05196, 0.00000], -[3390, 0.18250, 0.04763, 0.00000], -[3391, 0.18500, 0.04330, 0.00000], -[3392, 0.15500, 0.09300, 0.00000], -[3393, 0.21500, 0.00000, 0.00000], -[3394, 0.18750, 0.03897, 0.00000], -[3395, 0.19000, 0.03464, 0.00000], -[3396, 0.19250, 0.03031, 0.00000], -[3397, 0.19500, 0.02598, 0.00000], -[3398, 0.19750, 0.02165, 0.00000], -[3399, 0.15601, 0.08744, 0.00000], -[3400, 0.20000, 0.01732, 0.00000], -[3401, 0.04500, 0.50800, 0.00000], -[3402, 0.20250, 0.01299, 0.00000], -[3403, 0.20500, 0.00866, 0.00000], -[3404, 0.16000, 0.07794, 0.00000], -[3405, 0.15750, 0.08227, 0.00000], -[3406, 0.16250, 0.07361, 0.00000], -[3407, 0.16500, 0.06928, 0.00000], -[3408, 0.16750, 0.06495, 0.00000], -[3409, 0.17000, 0.06062, 0.00000], -[3410, 0.20750, 0.00433, 0.00000], -[3411, 0.17250, 0.05629, 0.00000], -[3412, 0.17500, 0.05196, 0.00000], -[3413, 0.17750, 0.04763, 0.00000], -[3414, 0.21000, 0.00000, 0.00000], -[3415, 0.18000, 0.04330, 0.00000], -[3416, 0.15000, 0.09300, 0.00000], -[3417, 0.18250, 0.03897, 0.00000], -[3418, 0.18500, 0.03464, 0.00000], -[3419, 0.18750, 0.03031, 0.00000], -[3420, 0.19000, 0.02598, 0.00000], -[3421, 0.19250, 0.02165, 0.00000], -[3422, 0.19500, 0.01732, 0.00000], -[3423, 0.15100, 0.08743, 0.00000], -[3424, 0.19750, 0.01299, 0.00000], -[3425, 0.20000, 0.00866, 0.00000], -[3426, 0.04000, 0.50800, 0.00000], -[3427, 0.15500, 0.07794, 0.00000], -[3428, 0.15750, 0.07361, 0.00000], -[3429, 0.15250, 0.08227, 0.00000], -[3430, 0.16000, 0.06928, 0.00000], -[3431, 0.20250, 0.00433, 0.00000], -[3432, 0.16250, 0.06495, 0.00000], -[3433, 0.16500, 0.06062, 0.00000], -[3434, 0.16750, 0.05629, 0.00000], -[3435, 0.17000, 0.05196, 0.00000], -[3436, 0.20500, 0.00000, 0.00000], -[3437, 0.17250, 0.04763, 0.00000], -[3438, 0.17500, 0.04330, 0.00000], -[3439, 0.17750, 0.03897, 0.00000], -[3440, 0.14500, 0.09300, 0.00000], -[3441, 0.18000, 0.03464, 0.00000], -[3442, 0.18250, 0.03031, 0.00000], -[3443, 0.18500, 0.02598, 0.00000], -[3444, 0.18750, 0.02165, 0.00000], -[3445, 0.19000, 0.01732, 0.00000], -[3446, 0.19250, 0.01299, 0.00000], -[3447, 0.19500, 0.00866, 0.00000], -[3448, 0.19750, 0.00433, 0.00000], -[3449, 0.15250, 0.07361, 0.00000], -[3450, 0.15000, 0.07794, 0.00000], -[3451, 0.15500, 0.06928, 0.00000], -[3452, 0.14750, 0.08227, 0.00000], -[3453, 0.15750, 0.06495, 0.00000], -[3454, 0.14500, 0.08660, 0.00000], -[3455, 0.16000, 0.06062, 0.00000], -[3456, 0.16250, 0.05629, 0.00000], -[3457, 0.20000, 0.00000, 0.00000], -[3458, 0.16500, 0.05196, 0.00000], -[3459, 0.03500, 0.50800, 0.00000], -[3460, 0.16750, 0.04763, 0.00000], -[3461, 0.17000, 0.04330, 0.00000], -[3462, 0.17250, 0.03897, 0.00000], -[3463, 0.17500, 0.03464, 0.00000], -[3464, 0.14000, 0.09300, 0.00000], -[3465, 0.17750, 0.03031, 0.00000], -[3466, 0.18000, 0.02598, 0.00000], -[3467, 0.18250, 0.02165, 0.00000], -[3468, 0.18500, 0.01732, 0.00000], -[3469, 0.18750, 0.01299, 0.00000], -[3470, 0.19000, 0.00866, 0.00000], -[3471, 0.19250, 0.00433, 0.00000], -[3472, 0.14750, 0.07361, 0.00000], -[3473, 0.15000, 0.06928, 0.00000], -[3474, 0.14500, 0.07794, 0.00000], -[3475, 0.15250, 0.06495, 0.00000], -[3476, 0.14250, 0.08227, 0.00000], -[3477, 0.19500, 0.00000, 0.00000], -[3478, 0.15500, 0.06062, 0.00000], -[3479, 0.14000, 0.08660, 0.00000], -[3480, 0.15750, 0.05629, 0.00000], -[3481, 0.16000, 0.05196, 0.00000], -[3482, 0.16250, 0.04763, 0.00000], -[3483, 0.16500, 0.04330, 0.00000], -[3484, 0.16750, 0.03897, 0.00000], -[3485, 0.03000, 0.50800, 0.00000], -[3486, 0.17000, 0.03464, 0.00000], -[3487, 0.17250, 0.03031, 0.00000], -[3488, 0.13500, 0.09300, 0.00000], -[3489, 0.17500, 0.02598, 0.00000], -[3490, 0.17750, 0.02165, 0.00000], -[3491, 0.18000, 0.01732, 0.00000], -[3492, 0.18250, 0.01299, 0.00000], -[3493, 0.18500, 0.00866, 0.00000], -[3494, 0.18750, 0.00433, 0.00000], -[3495, 0.19000, 0.00000, 0.00000], -[3496, 0.14500, 0.06928, 0.00000], -[3497, 0.14250, 0.07361, 0.00000], -[3498, 0.14750, 0.06495, 0.00000], -[3499, 0.14000, 0.07794, 0.00000], -[3500, 0.15000, 0.06062, 0.00000], -[3501, 0.13750, 0.08227, 0.00000], -[3502, 0.15250, 0.05629, 0.00000], -[3503, 0.13500, 0.08660, 0.00000], -[3504, 0.15500, 0.05196, 0.00000], -[3505, 0.15750, 0.04763, 0.00000], -[3506, 0.16000, 0.04330, 0.00000], -[3507, 0.16250, 0.03897, 0.00000], -[3508, 0.16500, 0.03464, 0.00000], -[3509, 0.16750, 0.03031, 0.00000], -[3510, 0.13000, 0.09300, 0.00000], -[3511, 0.17000, 0.02598, 0.00000], -[3512, 0.02500, 0.50800, 0.00000], -[3513, 0.17250, 0.02165, 0.00000], -[3514, 0.17500, 0.01732, 0.00000], -[3515, 0.17750, 0.01299, 0.00000], -[3516, 0.18000, 0.00866, 0.00000], -[3517, 0.18250, 0.00433, 0.00000], -[3518, 0.18500, 0.00000, 0.00000], -[3519, 0.14000, 0.06928, 0.00000], -[3520, 0.14250, 0.06495, 0.00000], -[3521, 0.13750, 0.07361, 0.00000], -[3522, 0.14500, 0.06062, 0.00000], -[3523, 0.13500, 0.07794, 0.00000], -[3524, 0.14750, 0.05629, 0.00000], -[3525, 0.13250, 0.08227, 0.00000], -[3526, 0.15000, 0.05196, 0.00000], -[3527, 0.13000, 0.08660, 0.00000], -[3528, 0.15250, 0.04763, 0.00000], -[3529, 0.15500, 0.04330, 0.00000], -[3530, 0.15750, 0.03897, 0.00000], -[3531, 0.16000, 0.03464, 0.00000], -[3532, 0.16250, 0.03031, 0.00000], -[3533, 0.16500, 0.02598, 0.00000], -[3534, 0.12500, 0.09300, 0.00000], -[3535, 0.16750, 0.02165, 0.00000], -[3536, 0.17000, 0.01732, 0.00000], -[3537, 0.17250, 0.01299, 0.00000], -[3538, 0.02000, 0.50800, 0.00000], -[3539, 0.17500, 0.00866, 0.00000], -[3540, 0.17750, 0.00433, 0.00000], -[3541, 0.18000, 0.00000, 0.00000], -[3542, 0.13750, 0.06495, 0.00000], -[3543, 0.13500, 0.06928, 0.00000], -[3544, 0.14000, 0.06062, 0.00000], -[3545, 0.13250, 0.07361, 0.00000], -[3546, 0.14250, 0.05629, 0.00000], -[3547, 0.13000, 0.07794, 0.00000], -[3548, 0.14500, 0.05196, 0.00000], -[3549, 0.12750, 0.08227, 0.00000], -[3550, 0.14750, 0.04763, 0.00000], -[3551, 0.12500, 0.08660, 0.00000], -[3552, 0.15000, 0.04330, 0.00000], -[3553, 0.15250, 0.03897, 0.00000], -[3554, 0.15500, 0.03464, 0.00000], -[3555, 0.15750, 0.03031, 0.00000], -[3556, 0.16000, 0.02598, 0.00000], -[3557, 0.16250, 0.02165, 0.00000], -[3558, 0.12000, 0.09300, 0.00000], -[3559, 0.16500, 0.01732, 0.00000], -[3560, 0.16750, 0.01299, 0.00000], -[3561, 0.17000, 0.00866, 0.00000], -[3562, 0.17250, 0.00433, 0.00000], -[3563, 0.01500, 0.50800, 0.00000], -[3564, 0.17500, 0.00000, 0.00000], -[3565, 0.13250, 0.06495, 0.00000], -[3566, 0.13500, 0.06062, 0.00000], -[3567, 0.13000, 0.06928, 0.00000], -[3568, 0.13750, 0.05629, 0.00000], -[3569, 0.12750, 0.07361, 0.00000], -[3570, 0.14000, 0.05196, 0.00000], -[3571, 0.12500, 0.07794, 0.00000], -[3572, 0.14250, 0.04763, 0.00000], -[3573, 0.12250, 0.08227, 0.00000], -[3574, 0.14500, 0.04330, 0.00000], -[3575, 0.12000, 0.08660, 0.00000], -[3576, 0.14750, 0.03897, 0.00000], -[3577, 0.15000, 0.03464, 0.00000], -[3578, 0.15250, 0.03031, 0.00000], -[3579, 0.15500, 0.02598, 0.00000], -[3580, 0.15750, 0.02165, 0.00000], -[3581, 0.16000, 0.01732, 0.00000], -[3582, 0.11500, 0.09300, 0.00000], -[3583, 0.16250, 0.01299, 0.00000], -[3584, 0.16500, 0.00866, 0.00000], -[3585, 0.16750, 0.00433, 0.00000], -[3586, 0.17000, 0.00000, 0.00000], -[3587, 0.01000, 0.50800, 0.00000], -[3588, 0.13000, 0.06062, 0.00000], -[3589, 0.12750, 0.06495, 0.00000], -[3590, 0.13250, 0.05629, 0.00000], -[3591, 0.12500, 0.06928, 0.00000], -[3592, 0.13500, 0.05196, 0.00000], -[3593, 0.12250, 0.07361, 0.00000], -[3594, 0.13750, 0.04763, 0.00000], -[3595, 0.12000, 0.07794, 0.00000], -[3596, 0.14000, 0.04330, 0.00000], -[3597, 0.11750, 0.08227, 0.00000], -[3598, 0.14250, 0.03897, 0.00000], -[3599, 0.11500, 0.08660, 0.00000], -[3600, 0.14500, 0.03464, 0.00000], -[3601, 0.14750, 0.03031, 0.00000], -[3602, 0.15000, 0.02598, 0.00000], -[3603, 0.15250, 0.02165, 0.00000], -[3604, 0.15500, 0.01732, 0.00000], -[3605, 0.11000, 0.09300, 0.00000], -[3606, 0.15750, 0.01299, 0.00000], -[3607, 0.16000, 0.00866, 0.00000], -[3608, 0.16250, 0.00433, 0.00000], -[3609, 0.16500, 0.00000, 0.00000], -[3610, 0.12500, 0.06062, 0.00000], -[3611, 0.12750, 0.05629, 0.00000], -[3612, 0.12250, 0.06495, 0.00000], -[3613, 0.13000, 0.05196, 0.00000], -[3614, 0.12000, 0.06928, 0.00000], -[3615, 0.13250, 0.04763, 0.00000], -[3616, 0.11750, 0.07361, 0.00000], -[3617, 0.00500, 0.50800, 0.00000], -[3618, 0.13500, 0.04330, 0.00000], -[3619, 0.11500, 0.07794, 0.00000], -[3620, 0.13750, 0.03897, 0.00000], -[3621, 0.11250, 0.08227, 0.00000], -[3622, 0.14000, 0.03464, 0.00000], -[3623, 0.11000, 0.08660, 0.00000], -[3624, 0.14250, 0.03031, 0.00000], -[3625, 0.14500, 0.02598, 0.00000], -[3626, 0.14750, 0.02165, 0.00000], -[3627, 0.15000, 0.01732, 0.00000], -[3628, 0.15250, 0.01299, 0.00000], -[3629, 0.10500, 0.09300, 0.00000], -[3630, 0.15500, 0.00866, 0.00000], -[3631, 0.15750, 0.00433, 0.00000], -[3632, 0.16000, 0.00000, 0.00000], -[3633, 0.10568, 0.08748, 0.00000], -[3634, 0.12250, 0.05629, 0.00000], -[3635, 0.12000, 0.06062, 0.00000], -[3636, 0.12500, 0.05196, 0.00000], -[3637, 0.11750, 0.06495, 0.00000], -[3638, 0.12750, 0.04763, 0.00000], -[3639, 0.11500, 0.06928, 0.00000], -[3640, 0.13000, 0.04330, 0.00000], -[3641, 0.11250, 0.07361, 0.00000], -[3642, 0.13250, 0.03897, 0.00000], -[3643, 0.11000, 0.07794, 0.00000], -[3644, 0.13500, 0.03464, 0.00000], -[3645, 0.10750, 0.08227, 0.00000], -[3646, 0.13750, 0.03031, 0.00000], -[3647, 0.14000, 0.02598, 0.00000], -[3648, 0.00000, 0.50800, 0.00000], -[3649, 0.00000, 0.50302, 0.00000], -[3650, 0.00000, 0.49805, 0.00000], -[3651, 0.00000, 0.49307, 0.00000], -[3652, 0.14250, 0.02165, 0.00000], -[3653, 0.00000, 0.48810, 0.00000], -[3654, 0.00000, 0.48312, 0.00000], -[3655, 0.14500, 0.01732, 0.00000], -[3656, 0.00000, 0.47814, 0.00000], -[3657, 0.00000, 0.47317, 0.00000], -[3658, 0.14750, 0.01299, 0.00000], -[3659, 0.00000, 0.46819, 0.00000], -[3660, 0.15000, 0.00866, 0.00000], -[3661, 0.00000, 0.46321, 0.00000], -[3662, 0.10000, 0.09300, 0.00000], -[3663, 0.15250, 0.00433, 0.00000], -[3664, 0.00000, 0.45824, 0.00000], -[3665, 0.00000, 0.45326, 0.00000], -[3666, 0.15500, 0.00000, 0.00000], -[3667, 0.00000, 0.44829, 0.00000], -[3668, 0.00000, 0.44331, 0.00000], -[3669, 0.00000, 0.43833, 0.00000], -[3670, 0.00000, 0.43336, 0.00000], -[3671, 0.00000, 0.42838, 0.00000], -[3672, 0.11750, 0.05629, 0.00000], -[3673, 0.12000, 0.05196, 0.00000], -[3674, 0.11500, 0.06062, 0.00000], -[3675, 0.12250, 0.04763, 0.00000], -[3676, 0.11250, 0.06495, 0.00000], -[3677, 0.12500, 0.04330, 0.00000], -[3678, 0.11000, 0.06928, 0.00000], -[3679, 0.12750, 0.03897, 0.00000], -[3680, 0.10750, 0.07361, 0.00000], -[3681, 0.13000, 0.03464, 0.00000], -[3682, 0.10500, 0.07794, 0.00000], -[3683, 0.00000, 0.42340, 0.00000], -[3684, 0.13250, 0.03031, 0.00000], -[3685, 0.10250, 0.08227, 0.00000], -[3686, 0.13500, 0.02598, 0.00000], -[3687, 0.09917, 0.08786, 0.00000], -[3688, 0.13750, 0.02165, 0.00000], -[3689, 0.00000, 0.41843, 0.00000], -[3690, 0.14000, 0.01732, 0.00000], -[3691, 0.14250, 0.01299, 0.00000], -[3692, 0.00000, 0.41345, 0.00000], -[3693, 0.14500, 0.00866, 0.00000], -[3694, 0.00000, 0.40848, 0.00000], -[3695, 0.14750, 0.00433, 0.00000], -[3696, 0.09500, 0.09300, 0.00000], -[3697, 0.15000, 0.00000, 0.00000], -[3698, 0.00000, 0.40350, 0.00000], -[3699, 0.00000, 0.39852, 0.00000], -[3700, 0.00000, 0.39355, 0.00000], -[3701, 0.11500, 0.05196, 0.00000], -[3702, 0.11250, 0.05629, 0.00000], -[3703, 0.11750, 0.04763, 0.00000], -[3704, 0.11000, 0.06062, 0.00000], -[3705, 0.00000, 0.38857, 0.00000], -[3706, 0.12000, 0.04330, 0.00000], -[3707, 0.10750, 0.06495, 0.00000], -[3708, 0.12250, 0.03897, 0.00000], -[3709, 0.10500, 0.06928, 0.00000], -[3710, 0.09819, 0.08183, 0.00000], -[3711, 0.12500, 0.03464, 0.00000], -[3712, 0.10250, 0.07361, 0.00000], -[3713, 0.12750, 0.03031, 0.00000], -[3714, 0.10000, 0.07794, 0.00000], -[3715, 0.13000, 0.02598, 0.00000], -[3716, 0.00000, 0.38360, 0.00000], -[3717, 0.13250, 0.02165, 0.00000], -[3718, 0.13500, 0.01732, 0.00000], -[3719, 0.09350, 0.08869, 0.00000], -[3720, 0.13750, 0.01299, 0.00000], -[3721, 0.00000, 0.37862, 0.00000], -[3722, 0.14000, 0.00866, 0.00000], -[3723, 0.14250, 0.00433, 0.00000], -[3724, 0.00000, 0.37364, 0.00000], -[3725, 0.14500, 0.00000, 0.00000], -[3726, 0.09000, 0.09300, 0.00000], -[3727, 0.00000, 0.36867, 0.00000], -[3728, 0.09386, 0.08366, 0.00000], -[3729, 0.00000, 0.36369, 0.00000], -[3730, 0.11000, 0.05196, 0.00000], -[3731, 0.11250, 0.04763, 0.00000], -[3732, 0.10750, 0.05629, 0.00000], -[3733, 0.11500, 0.04330, 0.00000], -[3734, 0.10500, 0.06062, 0.00000], -[3735, 0.00000, 0.35871, 0.00000], -[3736, 0.11750, 0.03897, 0.00000], -[3737, 0.10250, 0.06495, 0.00000], -[3738, 0.12000, 0.03464, 0.00000], -[3739, 0.10000, 0.06928, 0.00000], -[3740, 0.12250, 0.03031, 0.00000], -[3741, 0.12500, 0.02598, 0.00000], -[3742, 0.09457, 0.07870, 0.00000], -[3743, 0.12750, 0.02165, 0.00000], -[3744, 0.13000, 0.01732, 0.00000], -[3745, 0.00000, 0.35374, 0.00000], -[3746, 0.13250, 0.01299, 0.00000], -[3747, 0.13500, 0.00866, 0.00000], -[3748, 0.13750, 0.00433, 0.00000], -[3749, 0.08947, 0.08593, 0.00000], -[3750, 0.00000, 0.34876, 0.00000], -[3751, 0.14000, 0.00000, 0.00000], -[3752, 0.09528, 0.07375, 0.00000], -[3753, 0.08500, 0.09300, 0.00000], -[3754, 0.00000, 0.34379, 0.00000], -[3755, 0.00000, 0.33881, 0.00000], -[3756, 0.08993, 0.08056, 0.00000], -[3757, 0.10750, 0.04763, 0.00000], -[3758, 0.10500, 0.05196, 0.00000], -[3759, 0.11000, 0.04330, 0.00000], -[3760, 0.10250, 0.05629, 0.00000], -[3761, 0.11250, 0.03897, 0.00000], -[3762, 0.10000, 0.06062, 0.00000], -[3763, 0.11500, 0.03464, 0.00000], -[3764, 0.09750, 0.06495, 0.00000], -[3765, 0.00000, 0.33383, 0.00000], -[3766, 0.11750, 0.03031, 0.00000], -[3767, 0.09500, 0.06928, 0.00000], -[3768, 0.08506, 0.08797, 0.00000], -[3769, 0.12000, 0.02598, 0.00000], -[3770, 0.12250, 0.02165, 0.00000], -[3771, 0.12500, 0.01732, 0.00000], -[3772, 0.12750, 0.01299, 0.00000], -[3773, 0.09064, 0.07561, 0.00000], -[3774, 0.00000, 0.32886, 0.00000], -[3775, 0.13000, 0.00866, 0.00000], -[3776, 0.13250, 0.00433, 0.00000], -[3777, 0.13500, 0.00000, 0.00000], -[3778, 0.00000, 0.32388, 0.00000], -[3779, 0.08000, 0.09300, 0.00000], -[3780, 0.08529, 0.08240, 0.00000], -[3781, 0.09135, 0.07066, 0.00000], -[3782, 0.00000, 0.31890, 0.00000], -[3783, 0.00000, 0.31393, 0.00000], -[3784, 0.07993, 0.08922, 0.00000], -[3785, 0.08600, 0.07748, 0.00000], -[3786, 0.10250, 0.04763, 0.00000], -[3787, 0.10500, 0.04330, 0.00000], -[3788, 0.10750, 0.03897, 0.00000], -[3789, 0.09750, 0.05629, 0.00000], -[3790, 0.11000, 0.03464, 0.00000], -[3791, 0.09500, 0.06062, 0.00000], -[3792, 0.11250, 0.03031, 0.00000], -[3793, 0.09250, 0.06495, 0.00000], -[3794, 0.09977, 0.05178, 0.00000], -[3795, 0.11500, 0.02598, 0.00000], -[3796, 0.11750, 0.02165, 0.00000], -[3797, 0.12000, 0.01732, 0.00000], -[3798, 0.12250, 0.01299, 0.00000], -[3799, 0.00000, 0.30895, 0.00000], -[3800, 0.12500, 0.00866, 0.00000], -[3801, 0.12750, 0.00433, 0.00000], -[3802, 0.08066, 0.08427, 0.00000], -[3803, 0.13000, 0.00000, 0.00000], -[3804, 0.08672, 0.07253, 0.00000], -[3805, 0.00000, 0.30398, 0.00000], -[3806, 0.07500, 0.09300, 0.00000], -[3807, 0.00000, 0.29900, 0.00000], -[3808, 0.08135, 0.07933, 0.00000], -[3809, 0.08742, 0.06758, 0.00000], -[3810, 0.00000, 0.29398, 0.00000], -[3811, 0.10000, 0.04330, 0.00000], -[3812, 0.09750, 0.04763, 0.00000], -[3813, 0.10250, 0.03897, 0.00000], -[3814, 0.10500, 0.03464, 0.00000], -[3815, 0.10750, 0.03031, 0.00000], -[3816, 0.11000, 0.02598, 0.00000], -[3817, 0.11250, 0.02165, 0.00000], -[3818, 0.07601, 0.08611, 0.00000], -[3819, 0.11500, 0.01732, 0.00000], -[3820, 0.08208, 0.07438, 0.00000], -[3821, 0.11750, 0.01299, 0.00000], -[3822, 0.12000, 0.00866, 0.00000], -[3823, 0.08897, 0.06077, 0.00000], -[3824, 0.00000, 0.28895, 0.00000], -[3825, 0.12250, 0.00433, 0.00000], -[3826, 0.12500, 0.00000, 0.00000], -[3827, 0.09360, 0.05086, 0.00000], -[3828, 0.09050, 0.05602, 0.00000], -[3829, 0.07673, 0.08117, 0.00000], -[3830, 0.08278, 0.06945, 0.00000], -[3831, 0.00000, 0.28393, 0.00000], -[3832, 0.07000, 0.09300, 0.00000], -[3833, 0.00000, 0.27890, 0.00000], -[3834, 0.07744, 0.07622, 0.00000], -[3835, 0.07129, 0.08794, 0.00000], -[3836, 0.08409, 0.06302, 0.00000], -[3837, 0.10000, 0.03464, 0.00000], -[3838, 0.10250, 0.03031, 0.00000], -[3839, 0.10500, 0.02598, 0.00000], -[3840, 0.09717, 0.03913, 0.00000], -[3841, 0.10750, 0.02165, 0.00000], -[3842, 0.09398, 0.04428, 0.00000], -[3843, 0.00000, 0.27388, 0.00000], -[3844, 0.11000, 0.01732, 0.00000], -[3845, 0.11250, 0.01299, 0.00000], -[3846, 0.11500, 0.00866, 0.00000], -[3847, 0.11750, 0.00433, 0.00000], -[3848, 0.07209, 0.08301, 0.00000], -[3849, 0.07814, 0.07131, 0.00000], -[3850, 0.08569, 0.05728, 0.00000], -[3851, 0.12000, 0.00000, 0.00000], -[3852, 0.00000, 0.26885, 0.00000], -[3853, 0.08715, 0.05232, 0.00000], -[3854, 0.07280, 0.07809, 0.00000], -[3855, 0.06716, 0.08904, 0.00000], -[3856, 0.06500, 0.09300, 0.00000], -[3857, 0.00000, 0.26383, 0.00000], -[3858, 0.08857, 0.04753, 0.00000], -[3859, 0.07861, 0.06503, 0.00000], -[3860, 0.07359, 0.07317, 0.00000], -[3861, 0.09500, 0.03464, 0.00000], -[3862, 0.00000, 0.25880, 0.00000], -[3863, 0.06742, 0.08477, 0.00000], -[3864, 0.10000, 0.02598, 0.00000], -[3865, 0.09750, 0.03003, 0.00000], -[3866, 0.10250, 0.02165, 0.00000], -[3867, 0.10500, 0.01732, 0.00000], -[3868, 0.08115, 0.05821, 0.00000], -[3869, 0.10750, 0.01299, 0.00000], -[3870, 0.11000, 0.00866, 0.00000], -[3871, 0.09156, 0.03892, 0.00000], -[3872, 0.08926, 0.04268, 0.00000], -[3873, 0.11250, 0.00433, 0.00000], -[3874, 0.11500, 0.00000, 0.00000], -[3875, 0.00000, 0.25378, 0.00000], -[3876, 0.06826, 0.07985, 0.00000], -[3877, 0.07422, 0.06822, 0.00000], -[3878, 0.08230, 0.05334, 0.00000], -[3879, 0.00000, 0.24876, 0.00000], -[3880, 0.08372, 0.04873, 0.00000], -[3881, 0.06000, 0.09300, 0.00000], -[3882, 0.06252, 0.08769, 0.00000], -[3883, 0.06896, 0.07491, 0.00000], -[3884, 0.09856, 0.02193, 0.00000], -[3885, 0.07414, 0.06395, 0.00000], -[3886, 0.07636, 0.05959, 0.00000], -[3887, 0.08499, 0.04371, 0.00000], -[3888, 0.00000, 0.24373, 0.00000], -[3889, 0.10000, 0.01732, 0.00000], -[3890, 0.10250, 0.01299, 0.00000], -[3891, 0.06964, 0.07020, 0.00000], -[3892, 0.10500, 0.00866, 0.00000], -[3893, 0.09226, 0.02938, 0.00000], -[3894, 0.10750, 0.00433, 0.00000], -[3895, 0.07751, 0.05479, 0.00000], -[3896, 0.09503, 0.02431, 0.00000], -[3897, 0.06324, 0.08161, 0.00000], -[3898, 0.11000, 0.00000, 0.00000], -[3899, 0.08623, 0.03891, 0.00000], -[3900, 0.00000, 0.23871, 0.00000], -[3901, 0.08848, 0.03398, 0.00000], -[3902, 0.07889, 0.04999, 0.00000], -[3903, 0.06435, 0.07674, 0.00000], -[3904, 0.07034, 0.06526, 0.00000], -[3905, 0.00000, 0.23368, 0.00000], -[3906, 0.05750, 0.08867, 0.00000], -[3907, 0.05500, 0.09300, 0.00000], -[3908, 0.08021, 0.04517, 0.00000], -[3909, 0.09579, 0.01797, 0.00000], -[3910, 0.06499, 0.07193, 0.00000], -[3911, 0.07092, 0.06030, 0.00000], -[3912, 0.00000, 0.22866, 0.00000], -[3913, 0.07292, 0.05604, 0.00000], -[3914, 0.08133, 0.04030, 0.00000], -[3915, 0.08770, 0.02901, 0.00000], -[3916, 0.10000, 0.00866, 0.00000], -[3917, 0.10250, 0.00433, 0.00000], -[3918, 0.09694, 0.01312, 0.00000], -[3919, 0.10500, 0.00000, 0.00000], -[3920, 0.05732, 0.08376, 0.00000], -[3921, 0.08984, 0.02428, 0.00000], -[3922, 0.06572, 0.06715, 0.00000], -[3923, 0.00000, 0.22363, 0.00000], -[3924, 0.07405, 0.05119, 0.00000], -[3925, 0.05960, 0.07819, 0.00000], -[3926, 0.08260, 0.03547, 0.00000], -[3927, 0.06714, 0.06237, 0.00000], -[3928, 0.07538, 0.04645, 0.00000], -[3929, 0.06084, 0.07339, 0.00000], -[3930, 0.09100, 0.01941, 0.00000], -[3931, 0.00000, 0.21861, 0.00000], -[3932, 0.05250, 0.08867, 0.00000], -[3933, 0.08375, 0.03062, 0.00000], -[3934, 0.06847, 0.05756, 0.00000], -[3935, 0.05000, 0.09300, 0.00000], -[3936, 0.07651, 0.04158, 0.00000], -[3937, 0.06163, 0.06846, 0.00000], -[3938, 0.09215, 0.01455, 0.00000], -[3939, 0.00000, 0.21359, 0.00000], -[3940, 0.08500, 0.02578, 0.00000], -[3941, 0.06930, 0.05270, 0.00000], -[3942, 0.09750, 0.00433, 0.00000], -[3943, 0.09428, 0.00941, 0.00000], -[3944, 0.05481, 0.07963, 0.00000], -[3945, 0.10000, 0.00000, 0.00000], -[3946, 0.07778, 0.03679, 0.00000], -[3947, 0.06230, 0.06352, 0.00000], -[3948, 0.07068, 0.04792, 0.00000], -[3949, 0.08621, 0.02084, 0.00000], -[3950, 0.00000, 0.20856, 0.00000], -[3951, 0.05603, 0.07470, 0.00000], -[3952, 0.05148, 0.08306, 0.00000], -[3953, 0.07893, 0.03193, 0.00000], -[3954, 0.06364, 0.05884, 0.00000], -[3955, 0.07174, 0.04305, 0.00000], -[3956, 0.08736, 0.01599, 0.00000], -[3957, 0.00000, 0.20354, 0.00000], -[3958, 0.04500, 0.09300, 0.00000], -[3959, 0.08019, 0.02712, 0.00000], -[3960, 0.06495, 0.05401, 0.00000], -[3961, 0.07305, 0.03824, 0.00000], -[3962, 0.05568, 0.07013, 0.00000], -[3963, 0.05770, 0.06544, 0.00000], -[3964, 0.08852, 0.01113, 0.00000], -[3965, 0.00000, 0.19851, 0.00000], -[3966, 0.08143, 0.02228, 0.00000], -[3967, 0.04645, 0.08671, 0.00000], -[3968, 0.09500, 0.00000, 0.00000], -[3969, 0.06588, 0.04921, 0.00000], -[3970, 0.04993, 0.07859, 0.00000], -[3971, 0.07415, 0.03338, 0.00000], -[3972, 0.05900, 0.06066, 0.00000], -[3973, 0.09060, 0.00469, 0.00000], -[3974, 0.06716, 0.04438, 0.00000], -[3975, 0.08257, 0.01742, 0.00000], -[3976, 0.00000, 0.19349, 0.00000], -[3977, 0.04675, 0.08171, 0.00000], -[3978, 0.07543, 0.02855, 0.00000], -[3979, 0.05971, 0.05576, 0.00000], -[3980, 0.05048, 0.07319, 0.00000], -[3981, 0.05364, 0.06674, 0.00000], -[3982, 0.06824, 0.03956, 0.00000], -[3983, 0.08373, 0.01256, 0.00000], -[3984, 0.04198, 0.08894, 0.00000], -[3985, 0.04000, 0.09300, 0.00000], -[3986, 0.00000, 0.18846, 0.00000], -[3987, 0.07656, 0.02369, 0.00000], -[3988, 0.06950, 0.03472, 0.00000], -[3989, 0.06028, 0.05080, 0.00000], -[3990, 0.09000, 0.00000, 0.00000], -[3991, 0.05434, 0.06180, 0.00000], -[3992, 0.08487, 0.00769, 0.00000], -[3993, 0.06240, 0.04590, 0.00000], -[3994, 0.07779, 0.01887, 0.00000], -[3995, 0.00000, 0.18344, 0.00000], -[3996, 0.05013, 0.06851, 0.00000], -[3997, 0.04228, 0.08395, 0.00000], -[3998, 0.05518, 0.05776, 0.00000], -[3999, 0.07062, 0.02989, 0.00000], -[4000, 0.04562, 0.07606, 0.00000], -[4001, 0.06347, 0.04102, 0.00000], -[4002, 0.07895, 0.01401, 0.00000], -[4003, 0.00000, 0.17841, 0.00000], -[4004, 0.07178, 0.02514, 0.00000], -[4005, 0.04257, 0.07896, 0.00000], -[4006, 0.05570, 0.05280, 0.00000], -[4007, 0.03779, 0.08740, 0.00000], -[4008, 0.04975, 0.06363, 0.00000], -[4009, 0.03500, 0.09300, 0.00000], -[4010, 0.06468, 0.03605, 0.00000], -[4011, 0.04567, 0.07106, 0.00000], -[4012, 0.08008, 0.00914, 0.00000], -[4013, 0.07302, 0.02030, 0.00000], -[4014, 0.00000, 0.17339, 0.00000], -[4015, 0.08500, 0.00000, 0.00000], -[4016, 0.06584, 0.03133, 0.00000], -[4017, 0.05035, 0.05888, 0.00000], -[4018, 0.05626, 0.04783, 0.00000], -[4019, 0.08123, 0.00428, 0.00000], -[4020, 0.07416, 0.01544, 0.00000], -[4021, 0.03811, 0.08121, 0.00000], -[4022, 0.05849, 0.04228, 0.00000], -[4023, 0.04557, 0.06634, 0.00000], -[4024, 0.00000, 0.16837, 0.00000], -[4025, 0.05170, 0.05422, 0.00000], -[4026, 0.06699, 0.02649, 0.00000], -[4027, 0.04131, 0.07351, 0.00000], -[4028, 0.03344, 0.08833, 0.00000], -[4029, 0.07540, 0.01060, 0.00000], -[4030, 0.05961, 0.03749, 0.00000], -[4031, 0.04632, 0.06146, 0.00000], -[4032, 0.06821, 0.02165, 0.00000], -[4033, 0.00000, 0.16334, 0.00000], -[4034, 0.03000, 0.09300, 0.00000], -[4035, 0.04214, 0.06792, 0.00000], -[4036, 0.03817, 0.07569, 0.00000], -[4037, 0.06102, 0.03269, 0.00000], -[4038, 0.07725, 0.00497, 0.00000], -[4039, 0.08000, 0.00000, 0.00000], -[4040, 0.03370, 0.08337, 0.00000], -[4041, 0.06945, 0.01680, 0.00000], -[4042, 0.04713, 0.05586, 0.00000], -[4043, 0.05111, 0.04835, 0.00000], -[4044, 0.00000, 0.15832, 0.00000], -[4045, 0.06220, 0.02791, 0.00000], -[4046, 0.07060, 0.01196, 0.00000], -[4047, 0.05509, 0.03872, 0.00000], -[4048, 0.03799, 0.07070, 0.00000], -[4049, 0.04187, 0.06307, 0.00000], -[4050, 0.03386, 0.07876, 0.00000], -[4051, 0.06340, 0.02301, 0.00000], -[4052, 0.05214, 0.04293, 0.00000], -[4053, 0.00000, 0.15329, 0.00000], -[4054, 0.02933, 0.08554, 0.00000], -[4055, 0.05618, 0.03386, 0.00000], -[4056, 0.04680, 0.05088, 0.00000], -[4057, 0.04214, 0.05925, 0.00000], -[4058, 0.06466, 0.01825, 0.00000], -[4059, 0.02500, 0.09300, 0.00000], -[4060, 0.07179, 0.00581, 0.00000], -[4061, 0.07500, 0.00000, 0.00000], -[4062, 0.05764, 0.02910, 0.00000], -[4063, 0.03765, 0.06573, 0.00000], -[4064, 0.03379, 0.07331, 0.00000], -[4065, 0.00000, 0.14827, 0.00000], -[4066, 0.02942, 0.08104, 0.00000], -[4067, 0.06581, 0.01338, 0.00000], -[4068, 0.04267, 0.05363, 0.00000], -[4069, 0.04675, 0.04590, 0.00000], -[4070, 0.02508, 0.08816, 0.00000], -[4071, 0.05859, 0.02436, 0.00000], -[4072, 0.00000, 0.14324, 0.00000], -[4073, 0.06693, 0.00862, 0.00000], -[4074, 0.05082, 0.03647, 0.00000], -[4075, 0.03354, 0.06855, 0.00000], -[4076, 0.03744, 0.06078, 0.00000], -[4077, 0.02965, 0.07609, 0.00000], -[4078, 0.05984, 0.01953, 0.00000], -[4079, 0.05287, 0.03059, 0.00000], -[4080, 0.02492, 0.08319, 0.00000], -[4081, 0.06812, 0.00377, 0.00000], -[4082, 0.04250, 0.04837, 0.00000], -[4083, 0.02000, 0.09300, 0.00000], -[4084, 0.04647, 0.04093, 0.00000], -[4085, 0.03833, 0.05610, 0.00000], -[4086, 0.00000, 0.13822, 0.00000], -[4087, 0.07000, 0.00000, 0.00000], -[4088, 0.06114, 0.01470, 0.00000], -[4089, 0.05396, 0.02573, 0.00000], -[4090, 0.03334, 0.06356, 0.00000], -[4091, 0.02929, 0.07115, 0.00000], -[4092, 0.02534, 0.07822, 0.00000], -[4093, 0.06215, 0.01001, 0.00000], -[4094, 0.00000, 0.13320, 0.00000], -[4095, 0.04235, 0.04373, 0.00000], -[4096, 0.03835, 0.05113, 0.00000], -[4097, 0.05503, 0.02086, 0.00000], -[4098, 0.02076, 0.08572, 0.00000], -[4099, 0.04610, 0.03596, 0.00000], -[4100, 0.03395, 0.05850, 0.00000], -[4101, 0.04809, 0.03203, 0.00000], -[4102, 0.06333, 0.00516, 0.00000], -[4103, 0.02529, 0.07407, 0.00000], -[4104, 0.02913, 0.06625, 0.00000], -[4105, 0.05631, 0.01599, 0.00000], -[4106, 0.00000, 0.12817, 0.00000], -[4107, 0.02114, 0.08086, 0.00000], -[4108, 0.04925, 0.02717, 0.00000], -[4109, 0.06500, 0.00000, 0.00000], -[4110, 0.01500, 0.09300, 0.00000], -[4111, 0.03802, 0.04617, 0.00000], -[4112, 0.04199, 0.03879, 0.00000], -[4113, 0.01664, 0.08846, 0.00000], -[4114, 0.03409, 0.05351, 0.00000], -[4115, 0.05741, 0.01144, 0.00000], -[4116, 0.05031, 0.02233, 0.00000], -[4117, 0.02514, 0.06912, 0.00000], -[4118, 0.00000, 0.12315, 0.00000], -[4119, 0.02867, 0.06127, 0.00000], -[4120, 0.02090, 0.07601, 0.00000], -[4121, 0.01691, 0.08347, 0.00000], -[4122, 0.05864, 0.00575, 0.00000], -[4123, 0.05158, 0.01756, 0.00000], -[4124, 0.03395, 0.04902, 0.00000], -[4125, 0.03802, 0.04129, 0.00000], -[4126, 0.02997, 0.05633, 0.00000], -[4127, 0.04196, 0.03380, 0.00000], -[4128, 0.00000, 0.11812, 0.00000], -[4129, 0.02103, 0.07186, 0.00000], -[4130, 0.02460, 0.06417, 0.00000], -[4131, 0.05265, 0.01269, 0.00000], -[4132, 0.06000, 0.00000, 0.00000], -[4133, 0.01000, 0.09300, 0.00000], -[4134, 0.04571, 0.02371, 0.00000], -[4135, 0.04307, 0.02837, 0.00000], -[4136, 0.01268, 0.08716, 0.00000], -[4137, 0.01671, 0.07863, 0.00000], -[4138, 0.03401, 0.04408, 0.00000], -[4139, 0.00000, 0.11310, 0.00000], -[4140, 0.05393, 0.00788, 0.00000], -[4141, 0.02577, 0.05889, 0.00000], -[4142, 0.03766, 0.03631, 0.00000], -[4143, 0.02957, 0.05137, 0.00000], -[4144, 0.04676, 0.01883, 0.00000], -[4145, 0.02068, 0.06689, 0.00000], -[4146, 0.01645, 0.07385, 0.00000], -[4147, 0.01290, 0.08075, 0.00000], -[4148, 0.04789, 0.01419, 0.00000], -[4149, 0.00000, 0.10807, 0.00000], -[4150, 0.02966, 0.04651, 0.00000], -[4151, 0.03354, 0.03913, 0.00000], -[4152, 0.02552, 0.05426, 0.00000], -[4153, 0.00863, 0.08820, 0.00000], -[4154, 0.03760, 0.03139, 0.00000], -[4155, 0.04159, 0.02407, 0.00000], -[4156, 0.02148, 0.06140, 0.00000], -[4157, 0.05500, 0.00000, 0.00000], -[4158, 0.01700, 0.06891, 0.00000], -[4159, 0.04911, 0.00917, 0.00000], -[4160, 0.00500, 0.09300, 0.00000], -[4161, 0.01286, 0.07578, 0.00000], -[4162, 0.04201, 0.02035, 0.00000], -[4163, 0.00000, 0.10305, 0.00000], -[4164, 0.02567, 0.04928, 0.00000], -[4165, 0.00866, 0.08321, 0.00000], -[4166, 0.02969, 0.04160, 0.00000], -[4167, 0.03354, 0.03415, 0.00000], -[4168, 0.05040, 0.00434, 0.00000], -[4169, 0.02140, 0.05653, 0.00000], -[4170, 0.03729, 0.02641, 0.00000], -[4171, 0.01721, 0.06395, 0.00000], -[4172, 0.04312, 0.01549, 0.00000], -[4173, 0.00000, 0.09802, 0.00000], -[4174, 0.01251, 0.07082, 0.00000], -[4175, 0.00863, 0.07822, 0.00000], -[4176, 0.04437, 0.01066, 0.00000], -[4177, 0.02559, 0.04430, 0.00000], -[4178, 0.02928, 0.03672, 0.00000], -[4179, 0.02132, 0.05158, 0.00000], -[4180, 0.05000, 0.00000, 0.00000], -[4181, 0.00433, 0.08566, 0.00000], -[4182, 0.03314, 0.02919, 0.00000], -[4183, 0.03724, 0.02183, 0.00000], -[4184, 0.01710, 0.05904, 0.00000], -[4185, 0.01285, 0.06634, 0.00000], -[4186, 0.00000, 0.09300, 0.00000], -[4187, 0.00845, 0.07369, 0.00000], -[4188, 0.03834, 0.01696, 0.00000], -[4189, 0.04488, 0.00517, 0.00000], -[4190, 0.02136, 0.04692, 0.00000], -[4191, 0.00433, 0.08076, 0.00000], -[4192, 0.02526, 0.03933, 0.00000], -[4193, 0.02912, 0.03173, 0.00000], -[4194, 0.01704, 0.05411, 0.00000], -[4195, 0.03307, 0.02420, 0.00000], -[4196, 0.00000, 0.08811, 0.00000], -[4197, 0.01292, 0.06138, 0.00000], -[4198, 0.03946, 0.01208, 0.00000], -[4199, 0.00849, 0.06876, 0.00000], -[4200, 0.00433, 0.07587, 0.00000], -[4201, 0.04500, 0.00000, 0.00000], -[4202, 0.03367, 0.01918, 0.00000], -[4203, 0.02110, 0.04211, 0.00000], -[4204, 0.02490, 0.03440, 0.00000], -[4205, 0.04038, 0.00682, 0.00000], -[4206, 0.01694, 0.04923, 0.00000], -[4207, 0.00000, 0.08321, 0.00000], -[4208, 0.02881, 0.02680, 0.00000], -[4209, 0.01294, 0.05640, 0.00000], -[4210, 0.00856, 0.06381, 0.00000], -[4211, 0.00433, 0.07097, 0.00000], -[4212, 0.03465, 0.01346, 0.00000], -[4213, 0.01712, 0.04429, 0.00000], -[4214, 0.00000, 0.07832, 0.00000], -[4215, 0.02076, 0.03718, 0.00000], -[4216, 0.02446, 0.02994, 0.00000], -[4217, 0.01297, 0.05141, 0.00000], -[4218, 0.02854, 0.02181, 0.00000], -[4219, 0.03587, 0.00862, 0.00000], -[4220, 0.00863, 0.05884, 0.00000], -[4221, 0.00433, 0.06608, 0.00000], -[4222, 0.04000, 0.00000, 0.00000], -[4223, 0.03015, 0.01684, 0.00000], -[4224, 0.02096, 0.03295, 0.00000], -[4225, 0.03712, 0.00378, 0.00000], -[4226, 0.00000, 0.07342, 0.00000], -[4227, 0.01722, 0.03930, 0.00000], -[4228, 0.01287, 0.04643, 0.00000], -[4229, 0.02435, 0.02455, 0.00000], -[4230, 0.00866, 0.05384, 0.00000], -[4231, 0.00433, 0.06118, 0.00000], -[4232, 0.02582, 0.01934, 0.00000], -[4233, 0.03106, 0.00998, 0.00000], -[4234, 0.00000, 0.06853, 0.00000], -[4235, 0.01729, 0.03431, 0.00000], -[4236, 0.01286, 0.04169, 0.00000], -[4237, 0.00863, 0.04905, 0.00000], -[4238, 0.01863, 0.02922, 0.00000], -[4239, 0.00433, 0.05629, 0.00000], -[4240, 0.03500, 0.00000, 0.00000], -[4241, 0.03229, 0.00401, 0.00000], -[4242, 0.00000, 0.06363, 0.00000], -[4243, 0.02582, 0.01434, 0.00000], -[4244, 0.01296, 0.03671, 0.00000], -[4245, 0.02122, 0.02088, 0.00000], -[4246, 0.00866, 0.04405, 0.00000], -[4247, 0.00433, 0.05139, 0.00000], -[4248, 0.00000, 0.05874, 0.00000], -[4249, 0.02150, 0.01685, 0.00000], -[4250, 0.02567, 0.00937, 0.00000], -[4251, 0.01724, 0.02436, 0.00000], -[4252, 0.01296, 0.03191, 0.00000], -[4253, 0.02756, 0.00505, 0.00000], -[4254, 0.00863, 0.03906, 0.00000], -[4255, 0.03000, 0.00000, 0.00000], -[4256, 0.00433, 0.04650, 0.00000], -[4257, 0.00000, 0.05384, 0.00000], -[4258, 0.01720, 0.01930, 0.00000], -[4259, 0.02135, 0.01186, 0.00000], -[4260, 0.01299, 0.02692, 0.00000], -[4261, 0.00863, 0.03436, 0.00000], -[4262, 0.00433, 0.04161, 0.00000], -[4263, 0.00000, 0.04895, 0.00000], -[4264, 0.01713, 0.01452, 0.00000], -[4265, 0.01296, 0.02193, 0.00000], -[4266, 0.02195, 0.00578, 0.00000], -[4267, 0.00866, 0.02937, 0.00000], -[4268, 0.02500, 0.00000, 0.00000], -[4269, 0.00433, 0.03671, 0.00000], -[4270, 0.00000, 0.04405, 0.00000], -[4271, 0.01715, 0.00957, 0.00000], -[4272, 0.01279, 0.01696, 0.00000], -[4273, 0.00866, 0.02447, 0.00000], -[4274, 0.00433, 0.03182, 0.00000], -[4275, 0.00000, 0.03916, 0.00000], -[4276, 0.02000, 0.00000, 0.00000], -[4277, 0.01736, 0.00423, 0.00000], -[4278, 0.00863, 0.01968, 0.00000], -[4279, 0.01282, 0.01203, 0.00000], -[4280, 0.00433, 0.02692, 0.00000], -[4281, 0.00000, 0.03426, 0.00000], -[4282, 0.00866, 0.01468, 0.00000], -[4283, 0.00433, 0.02203, 0.00000], -[4284, 0.00000, 0.02937, 0.00000], -[4285, 0.01277, 0.00575, 0.00000], -[4286, 0.01500, 0.00000, 0.00000], -[4287, 0.00863, 0.00969, 0.00000], -[4288, 0.00433, 0.01713, 0.00000], -[4289, 0.00000, 0.02447, 0.00000], -[4290, 0.00433, 0.01224, 0.00000], -[4291, 0.00845, 0.00471, 0.00000], -[4292, 0.00000, 0.01958, 0.00000], -[4293, 0.01000, 0.00000, 0.00000], -[4294, 0.00433, 0.00734, 0.00000], -[4295, 0.00000, 0.01468, 0.00000], -[4296, 0.00000, 0.00979, 0.00000], -[4297, 0.00500, 0.00000, 0.00000], -[4298, 0.00000, 0.00489, 0.00000], -[4299, 0.00000, 0.00000, 0.00000] -]) - diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.prb b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.prb deleted file mode 100644 index f54441733ea6..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.prb +++ /dev/null @@ -1,8 +0,0 @@ -PROBLEM DATA -QUESTION: END_TIME -VALUE: 0.1 -QUESTION: DELTA_TIME -VALUE: 0.001 -END PROBLEM DATA -INTERVAL DATA -END INTERVAL DATA diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.prop b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.prop deleted file mode 100644 index d482705983d1..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.prop +++ /dev/null @@ -1,9 +0,0 @@ -PROPERTIES[1][END_TIME] = 0.1; -PROPERTIES[1][DELTA_TIME] = 0.001; - -PROPERTIES[1][DENSITY] = 1.200000; -PROPERTIES[1][VISCOSITY] = 0.000017; -PROPERTIES[1][BODY_FORCE] = [0.000, 0.000000, 0.000]; -PROPERTIES[1][TIME_PARAMETER] = 0.5; -PROPERTIES[1][STABILIZATION_FACTOR] = 1.000000; - diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.py b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.py deleted file mode 100644 index 4dc2a411f587..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.py +++ /dev/null @@ -1,228 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# -# -# setting the domain size for the problem to be solved -domain_size = 2 - -# -# -# ATTENTION: here the order is important - -# including kratos path -kratos_path = '../../../../' # kratos_root/ -import sys -sys.path.append(kratos_path) - -# importing Kratos main library -from KratosMultiphysics import * - -# importing applications -from KratosMultiphysics.IncompressibleFluidApplicationimport * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * - -# from now on the order is not anymore crucial -# -# - -import math - - -def SelectSolidNodes(model_part, solid_nodes): - print "in SelectSolidNodes" - for node in model_part.Nodes: - if(node.GetSolutionStepValue(IS_STRUCTURE) == 1): - solid_nodes.append(node) - print solid_nodes - - -def FindNode(node_list, x, y, z): - for node in node_list: - a = (node.X - x) ** 2 - a = a + (node.Y - y) * (node.Y - y) - a = a + (node.Z - z) * (node.Z - z) - if (a < 0.0000001): - return node - - -def PrintForce(time, filename, node1, node2): - print "in print force", time - outstring = str(time) + " " - outstring += str(node1.GetSolutionStepValue(PRESSURE)) + " " - outstring += str(node2.GetSolutionStepValue(PRESSURE)) + "\n" - filename.write(outstring) - - -def MoveSolidNodes(alpha_max_grad, T, Dt, time, solid_nodes, xc, yc): - dist = Vector(3) - out = Vector(3) - disp = Vector(3) - vel = Vector(3) - center = Vector(3) - center[0] = xc - center[1] = yc - center[2] = 0.0 - - # calculate rotation matrix - alpha_rad = alpha_max_grad * 3.1415 / 180.0 - w = 2.0 * 3.1415 / T - # incremental angle - alpha = alpha_rad * (math.sin(w * time) - math.sin(w * (time - Dt))); - - Rot = Matrix(3, 3) - Rot[0, 0] = math.cos(alpha) - Rot[0, 1] = -math.sin(alpha) - Rot[0, 2] = 0.0 - Rot[1, 0] = math.sin(alpha) - Rot[1, 1] = math.cos(alpha) - Rot[1, 2] = 0.0 - Rot[2, 0] = 0.0; Rot[2, 1] = 0.0; Rot[2, 2] = 0.0; - - for i in range(0, len(solid_nodes)): - dist[0] = solid_nodes[i].X - dist[1] = solid_nodes[i].Y - dist[2] = 0.0 - dist = dist - center - - # calcualte incremental displacement - pos = Rot * dist + center - - disp[0] = pos[0] - solid_nodes[i].X; - disp[1] = pos[1] - solid_nodes[i].Y; - disp[2] = 0.0 - - # calculate vel - vel = disp / Dt - solid_nodes[i].SetSolutionStepValue(VELOCITY, 0, vel) - - # calcualte total displacement - step_in_the_past = 1 - old_disp = solid_nodes[i].GetSolutionStepValue(DISPLACEMENT, step_in_the_past) - disp = disp + old_disp - solid_nodes[i].SetSolutionStepValue(DISPLACEMENT, 0, disp) - - -# defining a model part -model_part = ModelPart("FluidPart"); - -# importing the variables files -import pfem_solver_ale -pfem_solver_ale.AddVariables(model_part) - -# reading a model -gid_mode_flag = GiDPostMode.GiD_PostBinary -use_multifile = MultiFileFlag.MultipleFiles -deformed_print_flag = WriteDeformedMeshFlag.WriteDeformed -write_conditions = WriteConditionsFlag.WriteConditions -gid_io = GidIO("sloshing_experimental", gid_mode_flag, use_multifile, deformed_print_flag, write_conditions) -gid_io.ReadModelPart(model_part) -print model_part - -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(2) - -# importing the solver files -pfem_solver_ale.AddDofs(model_part) - -# for node in model_part.Nodes: -# node.GetSolutionStepValue(TEMPERATURE); - -# setting the limits of the bounding box -box_corner1 = Vector(3); box_corner1[0] = -1.5; box_corner1[1] = -1.5; box_corner1[2] = -0.5; -box_corner2 = Vector(3); box_corner2[0] = 1.5; box_corner2[1] = 1.5; box_corner2[2] = 0.1; - -# selecting the nodes for the motion of the gate -solid_nodes = [] -SelectSolidNodes(model_part, solid_nodes) - -# creating a fluid solver object -name = str("sloshing_experimental") - -solver = pfem_solver_ale.PFEMSolver(model_part, name, box_corner1, box_corner2, domain_size) -solver.predictor_corrector = False -solver.max_vel_its = 5; -solver.max_press_its = 5; -solver.alpha_shape = 1.5 -solver.eulerian_lagrangian = False -# pDiagPrecond = DiagonalPreconditioner() -# solver.pressure_linear_solver = CGSolver(1e-4, 5000,pDiagPrecond) -# solver.pressure_linear_solver = SkylineLUFactorizationSolver() - -gravity = Vector(3) -gravity[0] = 0.00; gravity[1] = -9.81; gravity[2] = 0.0; -for node in model_part.Nodes: - node.SetSolutionStepValue(VISCOSITY, 0, 0.000001) - node.SetSolutionStepValue(DENSITY, 0, 1000.00000) - node.SetSolutionStepValue(BODY_FORCE, 0, gravity) - -Dt = 0.005 -nsteps = 6 -output_Dt = 0.1 -min_dt = 0.1 * Dt -max_dt = 2 * Dt -tmax = 20.00 -safety_factor = 0.9 - -# initializing the solver -solver.Initialize(Dt, output_Dt) - -node_0_093 = FindNode(model_part.Nodes, 0.0, 0.093, 0.0) -node_0_299 = FindNode(model_part.Nodes, 0.0, 0.299, 0.0) - -scalarout = open("pressure_history.out", 'w') -scalarout.write("time (0.0,0.093) (0.0,0.299) \n") - -time = 0.0 -step = 0 -new_Dt = 0.00 -# for step in range(0,nsteps): -while (time < tmax): - step = step + 1 - if(step <= 3): - new_Dt = 0.000001 - else: -# new_Dt = Dt - new_Dt = solver.EstimateDeltaTime(min_dt, max_dt) - new_Dt = safety_factor * new_Dt - - # step = step + 1 - time = time + new_Dt - print "time = ", time, " new_Dt= ", new_Dt, " step = ", step - - # time = Dt*step - model_part.CloneTimeStep(time) - - # moving the gate - alpha_max_grad = 4.0; - T = 1.91; - xc = 0.45; yc = 0.184; - MoveSolidNodes(alpha_max_grad, T, new_Dt, time, solid_nodes, xc, yc) - - print time - # print model_part.ProcessInfo()[TIME] - - # solving the fluid problem - - if(step > 3): - solver.Solve(time, gid_io) - PrintForce(time, scalarout, node_0_093, node_0_299) - scalarout.flush() - - -# -# chapuza to identify the effect of the mesh motion -# solver.close_result_file = False -# for node in model_part.Nodes: -# vel = node.GetSolutionStepValue(VELOCITY); -# mesh_vel = node.GetSolutionStepValue(MESH_VELOCITY); -# temp = (vel[0]-mesh_vel[0])**2 + (vel[1]-mesh_vel[1])**2 + (vel[2]-mesh_vel[2])**2 -# denom = (vel[0])**2 + (vel[1])**2 + (vel[2])**2 -# -# if (denom < 0.000001): -# node.SetSolutionStepValue(TEMPERATURE,0,0.00); -# else: -# node.SetSolutionStepValue(TEMPERATURE,0,temp/denom); -# -# gid_io.WriteNodalResults(TEMPERATURE, model_part.Nodes, time, 0); -# gid_io.Flush() -# gid_io.CloseResultFile(); diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.rdr b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.rdr deleted file mode 100644 index 1696639aec8e..000000000000 Binary files a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.rdr and /dev/null differ diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.uni b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.uni deleted file mode 100644 index 0468052e4eaa..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental.uni +++ /dev/null @@ -1,2 +0,0 @@ -model: m -problem: INTERNATIONAL diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.cond b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.cond deleted file mode 100644 index edcdc7ddea8c..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.cond +++ /dev/null @@ -1,4 +0,0 @@ - - -// Fixing degrees of freedom in nodes - diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.elem b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.elem deleted file mode 100644 index 0ae3af287a75..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.elem +++ /dev/null @@ -1,4 +0,0 @@ -// Reading Elements - -ElementsGroup = structural_group; - diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.init b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.init deleted file mode 100644 index a38ceb280841..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.init +++ /dev/null @@ -1,2 +0,0 @@ -// Fixing degrees of freedom in nodes - diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.node b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.node deleted file mode 100644 index 012511bac10d..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.node +++ /dev/null @@ -1,3 +0,0 @@ -NODES = NodesList([ - -]) diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.prop b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.prop deleted file mode 100644 index 35e8d773cd8a..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_experimental_structure.prop +++ /dev/null @@ -1,5 +0,0 @@ -PROPERTIES[1][END_TIME] = 0.1; -PROPERTIES[1][DELTA_TIME] = 0.001; - - - diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_lagrangian.py b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_lagrangian.py deleted file mode 100644 index 0e0a96bd7567..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/sloshing_lagrangian.py +++ /dev/null @@ -1,219 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# -# -# setting the domain size for the problem to be solved -domain_size = 2 - -# -# -# ATTENTION: here the order is important - -# including kratos path -kratos_path = '../../../../' # kratos_root/ -import sys -sys.path.append(kratos_path) - -# importing Kratos main library -from KratosMultiphysics import * - -# importing applications -from KratosMultiphysics.IncompressibleFluidApplicationimport * -from KratosMultiphysics.PFEMApplication import * -from KratosMultiphysics.MeshingApplication import * - -# from now on the order is not anymore crucial -# -# - -import math - - -def SelectSolidNodes(model_part, solid_nodes): - print "in SelectSolidNodes" - for node in model_part.Nodes: - if(node.GetSolutionStepValue(IS_STRUCTURE) == 1): - solid_nodes.append(node) - print solid_nodes - - -def FindNode(node_list, x, y, z): - for node in node_list: - a = (node.X - x) ** 2 - a = a + (node.Y - y) * (node.Y - y) - a = a + (node.Z - z) * (node.Z - z) - if (a < 0.0000001): - return node - - -def PrintForce(time, filename, node1, node2): - print "in print force", time - outstring = str(time) + " " - outstring += str(node1.GetSolutionStepValue(PRESSURE)) + " " - outstring += str(node2.GetSolutionStepValue(PRESSURE)) + "\n" - filename.write(outstring) - - -def MoveSolidNodes(alpha_max_grad, T, Dt, time, solid_nodes, xc, yc): - dist = Vector(3) - out = Vector(3) - disp = Vector(3) - vel = Vector(3) - center = Vector(3) - center[0] = xc - center[1] = yc - center[2] = 0.0 - - # calculate rotation matrix - alpha_rad = alpha_max_grad * 3.1415 / 180.0 - w = 2.0 * 3.1415 / T - # incremental angle - alpha = alpha_rad * (math.sin(w * time) - math.sin(w * (time - Dt))); - - Rot = Matrix(3, 3) - Rot[0, 0] = math.cos(alpha) - Rot[0, 1] = -math.sin(alpha) - Rot[0, 2] = 0.0 - Rot[1, 0] = math.sin(alpha) - Rot[1, 1] = math.cos(alpha) - Rot[1, 2] = 0.0 - Rot[2, 0] = 0.0; Rot[2, 1] = 0.0; Rot[2, 2] = 0.0; - - for i in range(0, len(solid_nodes)): - dist[0] = solid_nodes[i].X - dist[1] = solid_nodes[i].Y - dist[2] = 0.0 - dist = dist - center - - # calcualte incremental displacement - pos = Rot * dist + center - - disp[0] = pos[0] - solid_nodes[i].X; - disp[1] = pos[1] - solid_nodes[i].Y; - disp[2] = 0.0 - - # calculate vel - vel = disp / Dt - solid_nodes[i].SetSolutionStepValue(VELOCITY, 0, vel) - - # calcualte total displacement - step_in_the_past = 1 - old_disp = solid_nodes[i].GetSolutionStepValue(DISPLACEMENT, step_in_the_past) - disp = disp + old_disp - solid_nodes[i].SetSolutionStepValue(DISPLACEMENT, 0, disp) - - -# defining a model part -model_part = ModelPart("FluidPart"); - -# adding of Variables to Model Part should be here when the "very fix container will be ready" - -# reading a model -gid_io = GidIO("sloshing_experimental", GiDPostMode.GiD_PostBinary) -gid_io.ReadMesh(model_part.GetMesh()) -print model_part - -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(2) - -# importing the solver files -import pfem_solver_lagrangian -pfem_solver_lagrangian.AddVariables(model_part) - -# for node in model_part.Nodes: -# node.GetSolutionStepValue(TEMPERATURE); - -# setting the limits of the bounding box -box_corner1 = Vector(3); box_corner1[0] = -1.5; box_corner1[1] = -1.5; box_corner1[2] = -0.5; -box_corner2 = Vector(3); box_corner2[0] = 1.5; box_corner2[1] = 1.5; box_corner2[2] = 0.1; - -# selecting the nodes for the motion of the gate -solid_nodes = [] -SelectSolidNodes(model_part, solid_nodes) - -# creating a fluid solver object -name = str("sloshing_experimental") - -solver = pfem_solver_lagrangian.PFEMSolver(model_part, name, box_corner1, box_corner2, domain_size) -solver.predictor_corrector = False -solver.max_vel_its = 3; -solver.max_press_its = 3; -# pDiagPrecond = DiagonalPreconditioner() -# solver.pressure_linear_solver = CGSolver(1e-4, 5000,pDiagPrecond) -solver.pressure_linear_solver = SkylineLUFactorizationSolver() - -gravity = Vector(3) -gravity[0] = 0.00; gravity[1] = -9.81; gravity[2] = 0.0; -for node in model_part.Nodes: - node.SetSolutionStepValue(VISCOSITY, 0, 0.000001) - node.SetSolutionStepValue(DENSITY, 0, 1000.00000) - node.SetSolutionStepValue(BODY_FORCE, 0, gravity) - -Dt = 0.005 -nsteps = 6 -output_Dt = 0.1 -min_dt = Dt -max_dt = Dt -tmax = 20.00 - -# initializing the solver -solver.Initialize(Dt, output_Dt) - -node_0_093 = FindNode(model_part.Nodes, 0.0, 0.093, 0.0) -node_0_299 = FindNode(model_part.Nodes, 0.0, 0.299, 0.0) - -scalarout = open("pressure_history.out", 'w') -scalarout.write("time (0.0,0.093) (0.0,0.299) \n") - -time = 0.0 -step = 0 -new_Dt = 0.00 -# for step in range(0,nsteps): -while (time < tmax): - step = step + 1 - if(step <= 3): - new_Dt = 0.000001 - else: -# new_Dt = Dt - new_Dt = solver.EstimateDeltaTime(min_dt, max_dt) - - # step = step + 1 - time = time + new_Dt - print "time = ", time, " new_Dt= ", new_Dt, " step = ", step - - # time = Dt*step - model_part.CloneTimeStep(time) - - # moving the gate - alpha_max_grad = 4.0; - T = 1.91; - xc = 0.45; yc = 0.184; - MoveSolidNodes(alpha_max_grad, T, new_Dt, time, solid_nodes, xc, yc) - - print time - # print model_part.ProcessInfo()[TIME] - - # solving the fluid problem - - if(step > 3): - solver.Solve(time, gid_io) - PrintForce(time, scalarout, node_0_093, node_0_299) - scalarout.flush() - - -# -# chapuza to identify the effect of the mesh motion -# solver.close_result_file = False -# for node in model_part.Nodes: -# vel = node.GetSolutionStepValue(VELOCITY); -# mesh_vel = node.GetSolutionStepValue(MESH_VELOCITY); -# temp = (vel[0]-mesh_vel[0])**2 + (vel[1]-mesh_vel[1])**2 + (vel[2]-mesh_vel[2])**2 -# denom = (vel[0])**2 + (vel[1])**2 + (vel[2])**2 -# -# if (denom < 0.000001): -# node.SetSolutionStepValue(TEMPERATURE,0,0.00); -# else: -# node.SetSolutionStepValue(TEMPERATURE,0,temp/denom); -# -# gid_io.WriteNodalResults(TEMPERATURE, model_part.Nodes, time, 0); -# gid_io.Flush() -# gid_io.CloseResultFile(); diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/temp.csv b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/temp.csv deleted file mode 100644 index 0b34bb367726..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/temp.csv +++ /dev/null @@ -1,3151 +0,0 @@ -time (0.0,0.093) (0.0,0.299) -1e-06 0.0 0.0 -2e-06 0.0 0.0 -3e-06 0.0 0.0 -0.005003 -4.16618236481 0.0 -0.010003 21.1107481722 0.0 -0.015003 26.6256616313 0.0 -0.020003 30.8525744203 0.0 -0.025003 34.9170451591 0.0 -0.030003 40.4390384211 0.0 -0.036807068874 48.048595421 0.0 -0.0445775114661 56.6225598342 0.0 -0.0495775114661 60.7804746054 0.0 -0.0545775114661 63.8581905916 0.0 -0.0595775114661 64.3267830472 0.0 -0.0645775114661 63.650636665 0.0 -0.0695775114661 63.1440666027 0.0 -0.0745775114661 62.9832454355 0.0 -0.0795775114661 63.0163963045 0.0 -0.0845775114661 63.2502366167 0.0 -0.0895775114661 63.5430728906 0.0 -0.0945775114661 63.6303215231 0.0 -0.0995775114661 63.6813238692 0.0 -0.104577511466 63.7247790054 0.0 -0.109577511466 63.4896190727 0.0 -0.114577511466 63.3788030566 0.0 -0.119651670484 62.0983026863 0.0 -0.124651670484 62.334266762 0.0 -0.129651670484 63.0521569517 0.0 -0.134651670484 61.4839772287 0.0 -0.139651670484 61.1090790464 0.0 -0.144651670484 61.4239347392 0.0 -0.149651670484 62.4503159124 0.0 -0.154651670484 63.5695889301 0.0 -0.159651670484 63.9051969258 0.0 -0.164651670484 64.2075232768 0.0 -0.169651670484 64.7281727823 0.0 -0.174651670484 65.2678170512 0.0 -0.179651670484 65.7572181387 0.0 -0.184651670484 66.6895787449 0.0 -0.189651670484 68.1869271785 0.0 -0.194651670484 70.0256552358 0.0 -0.199651670484 71.83347209 0.0 -0.204651670484 73.4675418958 0.0 -0.209651670484 75.4042927653 0.0 -0.214651670484 76.2054087891 0.0 -0.219651670484 81.7631940182 0.0 -0.224651670484 85.0872714648 0.0 -0.229651670484 88.0636859381 0.0 -0.234651670484 90.8934349014 0.0 -0.239651670484 93.3968685761 0.0 -0.244651670484 96.0221990131 0.0 -0.249651670484 98.9703521051 0.0 -0.254651670484 102.082331491 0.0 -0.259651670484 105.390681688 0.0 -0.264651670484 109.390713094 0.0 -0.269651670484 113.183704886 0.0 -0.274651670484 116.940768567 0.0 -0.279651670484 119.315404257 0.0 -0.284651670484 121.576303916 0.0 -0.289651670484 125.595154851 0.0 -0.294651670484 128.063651793 0.0 -0.299651670484 130.511720113 0.0 -0.304651670484 132.53958681 0.0 -0.309651670484 135.072646529 0.0 -0.314651670484 137.32963976 0.0 -0.319651670484 139.056360729 0.0 -0.324651670484 140.447920969 0.0 -0.329651670484 141.632924016 0.0 -0.334651670484 142.853500444 0.0 -0.339651670484 143.64365341 0.0 -0.344651670484 145.206074749 0.0 -0.349651670484 146.588929932 0.0 -0.354651670484 147.913687163 0.0 -0.359651670484 148.964860296 0.0 -0.364651670484 149.416988901 0.0 -0.369651670484 149.986686912 0.0 -0.374651670484 150.744212284 0.0 -0.379651670484 152.014508903 0.0 -0.384651670484 153.56125384 0.0 -0.389651670484 155.678739746 0.0 -0.394651670484 157.80197974 0.0 -0.399651670484 160.29165957 0.0 -0.404651670484 162.923972259 0.0 -0.409651670484 165.557088266 0.0 -0.414651670484 167.996681351 0.0 -0.419651670484 170.70375692 0.0 -0.424651670484 174.70957138 0.0 -0.429651670484 177.579376886 0.0 -0.434651670484 180.59545241 0.0 -0.439651670484 183.35421011 0.0 -0.444651670484 186.015969833 0.0 -0.449651670484 188.968888743 0.0 -0.454651670484 191.646338515 0.0 -0.459651670484 194.795181032 0.0 -0.464651670484 197.692331333 0.0 -0.469651670484 200.750432994 0.0 -0.474651670484 203.571895842 0.0 -0.479651670484 207.204522808 0.0 -0.484651670484 210.655291775 0.0 -0.489651670484 215.401405191 0.0 -0.494651670484 219.058931925 0.0 -0.499651670484 222.530720914 0.0 -0.504651670484 225.817828244 0.0 -0.509651670484 229.490755477 0.0 -0.514651670484 232.494538394 0.0 -0.519651670484 235.396800241 0.0 -0.524651670484 238.39867768 0.0 -0.529651670484 241.308010836 0.0 -0.534651670484 240.942589772 0.0 -0.539651670484 247.583405296 0.0 -0.544651670484 250.16281755 0.0 -0.549651670484 252.115257137 0.0 -0.554651670484 247.391722052 0.0 -0.559651670484 256.18714516 0.0 -0.564651670484 258.389404628 0.0 -0.569651670484 260.354493524 0.0 -0.574651670484 261.886934975 0.0 -0.579651670484 263.885444583 0.0 -0.584651670484 266.802238202 0.0 -0.589651670484 268.899896201 0.0 -0.594651670484 270.986132311 0.0 -0.599651670484 273.352660451 0.0 -0.604651670484 268.577778823 0.0 -0.609651670484 277.916089868 0.0 -0.614651670484 280.512225671 0.0 -0.619651670484 280.949992653 0.0 -0.624651670484 275.436680079 0.0 -0.629651670484 285.726604686 0.0 -0.634651670484 288.004786997 0.0 -0.639651670484 290.154040069 0.0 -0.644651670484 292.05494182 0.0 -0.649651670484 293.496727661 0.0 -0.654651670484 295.062929866 0.0 -0.659651670484 297.237289019 0.0 -0.664651670484 300.05517585 0.0 -0.669651670484 302.697585804 0.0 -0.674651670484 306.010734859 0.0 -0.679651670484 308.377354627 0.0 -0.684651670484 310.223205919 0.0 -0.689651670484 312.36098924 0.0 -0.694651670484 314.692194474 0.0 -0.699651670484 316.685231878 0.0 -0.704651670484 318.568655322 0.0 -0.709651670484 320.462788858 0.0 -0.714651670484 320.265298337 0.0 -0.719651670484 324.486845648 0.0 -0.724651670484 324.629783894 0.0 -0.729651670484 324.661877006 0.0 -0.734651670484 325.060648344 0.0 -0.739651670484 321.142497575 0.0 -0.744651670484 326.518997656 0.0 -0.749651670484 327.120195702 0.0 -0.754651670484 327.352322259 0.0 -0.759651670484 327.968901565 0.0 -0.764651670484 327.949695367 0.0 -0.769651670484 328.236781888 0.0 -0.774651670484 323.89349117 0.0 -0.779651670484 328.856530199 0.0 -0.784651670484 329.332806206 0.0 -0.789651670484 329.296800684 0.0 -0.794651670484 328.920035123 0.0 -0.799651670484 322.590501679 0.0 -0.804651670484 328.138138373 0.0 -0.809651670484 327.902307294 0.0 -0.814651670484 327.054030911 0.0 -0.819651670484 324.573374624 0.0 -0.824651670484 324.19819769 0.0 -0.829651670484 317.46624891 0.0 -0.834651670484 323.480813511 0.0 -0.839651670484 323.171630621 0.0 -0.844651670484 321.36327256 0.0 -0.849651670484 318.192732828 0.0 -0.854651670484 315.685076982 0.0 -0.859651670484 313.813203774 0.0 -0.864651670484 314.043277845 0.0 -0.869651670484 305.280660205 0.0 -0.874651670484 312.070974734 0.0 -0.879651670484 311.268637437 0.0 -0.884651670484 309.270391945 0.0 -0.889651670484 306.611970004 0.0 -0.894651670484 299.180675774 0.0 -0.899651670484 300.328123456 0.0 -0.904651670484 299.860240838 0.0 -0.909651670484 295.252716986 0.0 -0.914651670484 297.139602661 0.0 -0.919651670484 296.498270329 0.0 -0.924651670484 295.865837229 0.0 -0.929651670484 295.030036414 0.0 -0.934651670484 294.476871176 0.0 -0.939651670484 293.535960785 0.0 -0.944651670484 290.402164528 0.0 -0.949820684135 291.705795551 0.0 -0.954820684135 290.661322088 0.0 -0.959820684135 285.398297398 0.0 -0.964820684135 286.520377411 0.0 -0.969820684135 284.112620587 0.0 -0.974820684135 281.316122791 0.0 -0.979820684135 273.500461827 0.0 -0.984820684135 274.460429315 0.0 -0.989820684135 271.387449944 0.0 -0.994820684135 267.947352858 0.0 -0.999820684135 253.209696837 0.0 -1.00482068413 258.275394927 0.0 -1.00982068413 254.331291529 0.0 -1.01482068413 250.126530899 0.0 -1.01982068413 240.799459217 0.0 -1.02482068413 240.429230366 0.0 -1.02982068413 236.686965598 0.0 -1.03482068413 226.99359996 0.0 -1.03982068413 226.985977759 0.0 -1.04482068413 223.739091105 0.0 -1.04982068413 220.651966271 0.0 -1.05482068413 211.471412514 0.0 -1.05982068413 211.357671444 0.0 -1.06482068413 208.362375614 0.0 -1.06982068413 199.820669848 0.0 -1.07482068413 200.206445252 0.0 -1.07982068413 198.845357148 0.0 -1.08482068413 189.31814501 0.0 -1.08982068413 189.313832454 0.0 -1.09482068413 185.960028742 0.0 -1.09982068413 176.524038256 0.0 -1.10482068413 177.089594224 0.0 -1.10982068413 170.777403523 0.0 -1.11482068413 159.873785914 0.0 -1.11982068413 158.149748808 0.0 -1.12482068413 151.736789882 0.0 -1.12982068413 147.875110251 0.0 -1.13482068413 145.026508228 0.0 -1.13982068413 142.833696807 0.0 -1.14482068413 139.275723309 0.0 -1.14982068413 136.545972779 0.0 -1.15482068413 123.916284433 0.0 -1.15982068413 116.816176297 0.0 -1.16482068413 110.190984439 0.0 -1.16982068413 103.027957756 0.0 -1.17482068413 108.507507453 0.0 -1.17982068413 110.89937986 0.0 -1.18482068413 112.828244054 0.0 -1.18982068413 113.47999426 0.0 -1.19482068413 101.313910507 0.0 -1.19982068413 104.742442311 0.0 -1.20482068413 108.609399467 0.0 -1.20982068413 103.9145089 0.0 -1.21482068413 98.5670052881 0.0 -1.21982068413 90.2696568285 0.0 -1.22482068413 78.970716796 0.0 -1.22982068413 74.0662084445 0.0 -1.23482068413 71.1804645948 0.0 -1.23982068413 69.2822521459 0.0 -1.24482068413 67.5584833424 0.0 -1.24982068413 65.9482128615 0.0 -1.25482068413 63.8971542939 0.0 -1.25982068413 61.7883979861 0.0 -1.26482068413 59.177912981 0.0 -1.26982068413 55.7154183381 0.0 -1.27482068413 51.3471079447 0.0 -1.27982068413 46.2860674803 0.0 -1.28482068413 40.1138805472 0.0 -1.28982068413 33.1077856435 0.0 -1.29482068413 26.3232582541 0.0 -1.29982068413 17.6255592819 0.0 -1.30482068413 11.0683419548 0.0 -1.30982068413 5.06606092325 0.0 -1.31482068413 0.457916708541 0.0 -1.31982068413 -12.977088118 0.0 -1.32482068413 -25.2690795185 0.0 -1.32982068413 -35.9179711143 0.0 -1.33482068413 -46.4510108197 0.0 -1.33982068413 -55.6430501838 0.0 -1.34482068413 -62.9004512024 0.0 -1.34982068413 -66.0629479319 0.0 -1.35482068413 -64.1891553406 0.0 -1.35982068413 -45.6098988449 0.0 -1.36482068413 -33.7824900567 0.0 -1.36982068413 -21.1275086262 0.0 -1.37482068413 -20.9194172734 0.0 -1.37982068413 -20.9194172734 0.0 -1.38482068413 -20.9194172734 0.0 -1.38982068413 -20.9194172734 0.0 -1.39482068413 -20.9194172734 0.0 -1.39982068413 -20.9194172734 0.0 -1.40482068413 -20.9194172734 0.0 -1.40982068413 -20.9194172734 0.0 -1.41482068413 -20.9194172734 0.0 -1.41982068413 -20.9194172734 0.0 -1.42482068413 -20.9194172734 0.0 -1.42982068413 -20.9194172734 0.0 -1.43482068413 -20.9194172734 0.0 -1.43982068413 -20.9194172734 0.0 -1.44482068413 -20.9194172734 0.0 -1.44982068413 -20.9194172734 0.0 -1.45482068413 -20.9194172734 0.0 -1.45982068413 -20.9194172734 0.0 -1.46482068413 -20.9194172734 0.0 -1.46982068413 -20.9194172734 0.0 -1.47482068413 -20.9194172734 0.0 -1.47982068413 -20.9194172734 0.0 -1.48482068413 -20.9194172734 0.0 -1.48982068413 -20.9194172734 0.0 -1.49482068413 -20.9194172734 0.0 -1.49982068413 -20.9194172734 0.0 -1.50482068413 -20.9194172734 0.0 -1.50982068413 -20.9194172734 0.0 -1.51482068413 -20.9194172734 0.0 -1.51982068413 -20.9194172734 0.0 -1.52482068413 -20.9194172734 0.0 -1.52982068413 -20.9194172734 0.0 -1.53482068413 -20.9194172734 0.0 -1.53982068413 -20.9194172734 0.0 -1.54482068413 -20.9194172734 0.0 -1.54982068413 -20.9194172734 0.0 -1.55482068413 -20.9194172734 0.0 -1.55982068413 -20.9194172734 0.0 -1.56482068413 -20.9194172734 0.0 -1.56982068413 -20.9194172734 0.0 -1.57482068413 -20.9194172734 0.0 -1.57982068413 -20.9194172734 0.0 -1.58482068413 -20.9194172734 0.0 -1.58982068413 -20.9194172734 0.0 -1.59482068413 -20.9194172734 0.0 -1.59982068413 -20.9194172734 0.0 -1.60482068413 -20.9194172734 0.0 -1.60982068413 -20.9194172734 0.0 -1.61482068413 -20.9194172734 0.0 -1.61982068413 -20.9194172734 0.0 -1.62482068413 -20.9194172734 0.0 -1.62982068413 -20.9194172734 0.0 -1.63482068413 -20.9194172734 0.0 -1.63982068413 -20.9194172734 0.0 -1.64482068413 -20.9194172734 0.0 -1.64982068413 -20.9194172734 0.0 -1.65482068413 -20.9194172734 0.0 -1.65982068413 -20.9194172734 0.0 -1.66482068413 -20.9194172734 0.0 -1.66982068413 -20.9194172734 0.0 -1.67482068413 -20.9194172734 0.0 -1.67982068413 -20.9194172734 0.0 -1.68482068413 -20.9194172734 0.0 -1.68982068413 -20.9194172734 0.0 -1.69482068413 -20.9194172734 0.0 -1.69982068413 -20.9194172734 0.0 -1.70482068413 -20.9194172734 0.0 -1.70982068413 -20.9194172734 0.0 -1.71482068413 -20.9194172734 0.0 -1.71982068413 -20.9194172734 0.0 -1.72482068413 -20.9194172734 0.0 -1.72982068413 -20.9194172734 0.0 -1.73482068413 -20.9194172734 0.0 -1.73982068413 -20.9194172734 0.0 -1.74482068413 -20.9194172734 0.0 -1.74982068413 -20.9194172734 0.0 -1.75482068413 -20.9194172734 0.0 -1.75982068413 -20.9194172734 0.0 -1.76482068413 -20.9194172734 0.0 -1.76982068413 -20.9194172734 0.0 -1.77482068413 -20.9194172734 0.0 -1.77982068413 -20.9194172734 0.0 -1.78482068413 -20.9194172734 0.0 -1.78982068413 -20.9194172734 0.0 -1.79482068413 -20.9194172734 0.0 -1.79982068413 -20.9194172734 0.0 -1.80482068413 -20.9194172734 0.0 -1.80982068413 -20.9194172734 0.0 -1.81482068413 -20.9194172734 0.0 -1.81982068413 -20.9194172734 0.0 -1.82482068413 -20.9194172734 0.0 -1.82982068413 -20.9194172734 0.0 -1.83482068413 -20.9194172734 0.0 -1.83982068413 -20.9194172734 0.0 -1.84482068413 -20.9194172734 0.0 -1.84982068413 -20.9194172734 0.0 -1.85482068413 -20.9194172734 0.0 -1.85982068413 -20.9194172734 0.0 -1.86482068413 -20.9194172734 0.0 -1.86982068413 -20.9194172734 0.0 -1.87482068413 -20.9194172734 0.0 -1.87982068413 -20.9194172734 0.0 -1.88482068413 -20.9194172734 0.0 -1.88982068413 -20.9194172734 0.0 -1.89482068413 -20.9194172734 0.0 -1.89982068413 -20.9194172734 0.0 -1.90482068413 -20.9194172734 0.0 -1.90982068413 -20.9194172734 0.0 -1.91482068413 -20.9194172734 0.0 -1.91982068413 -20.9194172734 0.0 -1.92482068413 -20.9194172734 0.0 -1.92982068413 -20.9194172734 0.0 -1.93482068413 -20.9194172734 0.0 -1.93982068413 -20.9194172734 0.0 -1.94482068413 -20.9194172734 0.0 -1.94982068413 -20.9194172734 0.0 -1.95482068413 -20.9194172734 0.0 -1.95982068413 -20.9194172734 0.0 -1.96482068413 -20.9194172734 0.0 -1.96982068413 -20.9194172734 0.0 -1.97482068413 -20.9194172734 0.0 -1.97982068413 -20.9194172734 0.0 -1.98482068413 -20.9194172734 0.0 -1.98982068413 -20.9194172734 0.0 -1.99482068413 -20.9194172734 0.0 -1.99982068413 -20.9194172734 0.0 -2.00482068413 -20.9194172734 0.0 -2.00982068413 -20.9194172734 0.0 -2.01482068413 -20.9194172734 0.0 -2.01982068413 -20.9194172734 0.0 -2.02482068413 -20.9194172734 0.0 -2.02982068413 -20.9194172734 0.0 -2.03482068413 -20.9194172734 0.0 -2.03982068413 -20.9194172734 0.0 -2.04482068413 -20.9194172734 0.0 -2.04982068413 -20.9194172734 0.0 -2.05482068413 -20.9194172734 0.0 -2.05982068413 -20.9194172734 0.0 -2.06482068413 -20.9194172734 0.0 -2.06982068413 -20.9194172734 0.0 -2.07482068413 -20.9194172734 0.0 -2.07982068413 -20.9194172734 0.0 -2.08482068413 -20.9194172734 0.0 -2.08982068413 -20.9194172734 0.0 -2.09482068413 -20.9194172734 0.0 -2.09982068413 -20.9194172734 0.0 -2.10482068413 -20.9194172734 0.0 -2.10982068413 -20.9194172734 0.0 -2.11482068413 -20.9194172734 0.0 -2.11982068413 -20.9194172734 0.0 -2.12482068413 -20.9194172734 0.0 -2.12982068413 -20.9194172734 0.0 -2.13482068413 -20.9194172734 0.0 -2.13982068413 -20.9194172734 0.0 -2.14482068413 -20.9194172734 0.0 -2.14982068413 -20.9194172734 0.0 -2.15482068413 -20.9194172734 0.0 -2.15982068413 -20.9194172734 0.0 -2.16482068413 -20.9194172734 0.0 -2.16982068413 -20.9194172734 0.0 -2.17482068413 -20.9194172734 0.0 -2.17982068413 -20.9194172734 0.0 -2.18482068413 -20.9194172734 0.0 -2.18982068413 -20.9194172734 0.0 -2.19482068413 -20.9194172734 0.0 -2.19982068413 -20.9194172734 0.0 -2.20482068413 -20.9194172734 0.0 -2.20982068413 -20.9194172734 0.0 -2.21482068413 -20.9194172734 0.0 -2.21982068413 -20.9194172734 0.0 -2.22482068413 -20.9194172734 0.0 -2.22982068413 -20.9194172734 0.0 -2.23482068413 -20.9194172734 0.0 -2.23982068413 -20.9194172734 0.0 -2.24482068413 -20.9194172734 0.0 -2.24982068413 -20.9194172734 0.0 -2.25482068413 -20.9194172734 0.0 -2.25982068413 -20.9194172734 0.0 -2.26482068413 -20.9194172734 0.0 -2.26982068413 -20.9194172734 0.0 -2.27482068413 -20.9194172734 0.0 -2.27982068413 -20.9194172734 0.0 -2.28482068413 -20.9194172734 0.0 -2.28982068413 -20.9194172734 0.0 -2.29482068413 -20.9194172734 0.0 -2.29982068413 -20.9194172734 0.0 -2.30482068413 -20.9194172734 0.0 -2.30982068413 -20.9194172734 0.0 -2.31482068413 -20.9194172734 0.0 -2.31982068413 -20.9194172734 0.0 -2.32482068413 -20.9194172734 0.0 -2.32982068413 -20.9194172734 0.0 -2.33482068413 -20.9194172734 0.0 -2.33982068413 -20.9194172734 0.0 -2.34482068413 -20.9194172734 0.0 -2.34982068413 -20.9194172734 0.0 -2.35482068413 -20.9194172734 0.0 -2.35982068413 -20.9194172734 0.0 -2.36482068413 -20.9194172734 0.0 -2.36982068413 -35.1101569922 0.0 -2.37482068413 -11.1440626842 0.0 -2.37982068413 135.619900964 0.0 -2.38482068413 285.002521652 0.0 -2.38982068413 436.726387083 0.0 -2.39482068413 604.945183886 0.0 -2.39982068413 820.15992783 0.0 -2.40482068413 993.696469878 0.0 -2.40982068413 1189.62810204 0.0 -2.41482068413 1364.50285447 0.0 -2.41982068413 1410.51036918 0.0 -2.42482068413 1374.01098869 0.0 -2.42982068413 1265.01030222 0.0 -2.43482068413 1130.05143764 0.0 -2.43982068413 1003.3537702 0.0 -2.44482068413 890.713362619 0.0 -2.44982068413 787.716840168 0.0 -2.45482068413 693.668296668 0.0 -2.45982068413 621.149380957 0.0 -2.46482068413 566.799356562 0.0 -2.46982068413 527.533759355 0.0 -2.47482068413 498.716775515 0.0 -2.47982068413 484.622624595 10.8562371475 -2.48482068413 482.970343068 3.62150439406 -2.48982068413 489.986780065 3.62150439406 -2.49482068413 505.793682856 3.62150439406 -2.49982068413 523.718940047 6.02288468643 -2.50482068413 544.755885396 3.33588642873 -2.50982068413 565.84903547 3.63657747298 -2.51482068413 588.418139134 3.79695689082 -2.51982068413 611.506850731 3.79695689082 -2.52482068413 631.278052713 3.79695689082 -2.52982068413 649.987661435 3.79695689082 -2.53482068413 664.438999927 3.79695689082 -2.53982068413 673.281112989 3.79695689082 -2.54482068413 679.912722663 3.79695689082 -2.54982068413 683.433447114 3.79695689082 -2.55482068413 684.816861743 8.93711977516 -2.55982068413 685.286398436 8.93711977516 -2.56482068413 683.256410242 8.93711977516 -2.56982068413 680.979859309 8.93711977516 -2.57482068413 678.776530441 8.93711977516 -2.57982068413 675.95878484 8.93711977516 -2.58482068413 673.454898919 8.93711977516 -2.58982068413 674.598224805 8.93711977516 -2.59482068413 676.858443612 8.93711977516 -2.59982068413 680.44142153 8.93711977516 -2.60482068413 684.822774977 8.93711977516 -2.60982068413 690.608318122 8.93711977516 -2.61482068413 699.379437256 8.93711977516 -2.61982068413 705.434860995 8.93711977516 -2.62482068413 713.903960189 8.93711977516 -2.62982068413 723.560416484 8.93711977516 -2.63482068413 735.27699896 8.93711977516 -2.63982068413 749.479928276 8.93711977516 -2.64482068413 765.246294092 8.93711977516 -2.64982068413 781.154333385 8.93711977516 -2.65482068413 797.971382076 8.93711977516 -2.65982068413 815.505604153 8.93711977516 -2.66482068413 835.856624281 1.16612142477 -2.66982068413 849.955542892 1.16612142477 -2.67482068413 867.145579244 0.838248116106 -2.67982068413 886.146104833 0.838248116106 -2.68482068413 900.182739635 0.838248116106 -2.68982068413 912.498358918 0.838248116106 -2.69482068413 922.341054439 0.838248116106 -2.69982068413 927.479028035 0.838248116106 -2.70482068413 927.411345129 0.838248116106 -2.70982068413 924.916262294 0.838248116106 -2.71482068413 921.430941126 0.838248116106 -2.71982068413 918.296278245 0.838248116106 -2.72482068413 913.078510493 0.838248116106 -2.72982068413 926.869861632 0.838248116106 -2.73482068413 913.542049918 0.838248116106 -2.73982068413 898.924374191 0.838248116106 -2.74482068413 896.55525593 -0.656545397406 -2.74982068413 870.650466695 -0.812601342163 -2.75482068413 845.716815545 -0.812601342163 -2.75982068413 808.680529901 -0.812601342163 -2.76482068413 777.60508001 -0.812601342163 -2.76982068413 751.215476964 -0.812601342163 -2.77482068413 721.408126149 -0.812601342163 -2.77982068413 694.251156417 -0.812601342163 -2.78482068413 647.673844686 -0.812601342163 -2.78982068413 584.126745796 -0.812601342163 -2.79482068413 530.216566073 -0.812601342163 -2.79982068413 479.292675481 -0.812601342163 -2.80482068413 434.21597592 -0.812601342163 -2.80982068413 395.801184388 -0.812601342163 -2.81482068413 363.218226796 -0.812601342163 -2.81982068413 385.068115076 -0.812601342163 -2.82482068413 378.432523482 -0.812601342163 -2.82982068413 337.864093255 -0.812601342163 -2.83482068413 296.335184505 -0.812601342163 -2.83982068413 443.246693857 -0.812601342163 -2.84482068413 340.136090177 -0.812601342163 -2.84982068413 346.902587382 -0.812601342163 -2.85482068413 315.447863043 -0.812601342163 -2.85982068413 284.129787803 -0.812601342163 -2.86482068413 284.125978014 -0.812601342163 -2.86982068413 270.436142144 -0.812601342163 -2.87482068413 261.780401058 -0.812601342163 -2.87982068413 230.833138904 -0.812601342163 -2.88482068413 227.44463052 -0.812601342163 -2.88982068413 224.430632202 -0.812601342163 -2.89482068413 244.171545882 -0.812601342163 -2.89982068413 246.210546956 -0.812601342163 -2.90482068413 237.197116222 -0.812601342163 -2.90982068413 228.827233429 -0.812601342163 -2.91482068413 237.137625829 -0.812601342163 -2.91982068413 240.414514084 -0.812601342163 -2.92482068413 253.192531682 -0.812601342163 -2.92982068413 318.555539327 -0.812601342163 -2.93482068413 329.700324068 -0.812601342163 -2.93982068413 365.049591888 -0.812601342163 -2.94482068413 320.662733929 -0.812601342163 -2.94982068413 289.447850664 -0.812601342163 -2.95482068413 299.009495979 -0.812601342163 -2.95982068413 299.654589916 -0.812601342163 -2.96482068413 311.856817526 -0.812601342163 -2.96982068413 284.984983809 -0.812601342163 -2.97482068413 280.291440876 -0.812601342163 -2.97982068413 295.413621087 -0.812601342163 -2.98482068413 307.347318447 -0.812601342163 -2.98982068413 330.986160112 -0.812601342163 -2.99482068413 325.854752477 -0.812601342163 -2.99982068413 326.140226597 -0.812601342163 -3.00482068413 321.787857517 -0.812601342163 -3.00982068413 320.815083376 -0.812601342163 -3.01482068413 326.278546482 -0.812601342163 -3.01982068413 314.731530605 -0.812601342163 -3.02482068413 303.910646835 -0.812601342163 -3.02982068413 279.160318778 -0.812601342163 -3.03482068413 270.135285271 -0.812601342163 -3.03982068413 252.993805341 -0.812601342163 -3.04482068413 237.421411403 -0.812601342163 -3.04982068413 226.046128693 -0.812601342163 -3.05482068413 229.356860431 -0.812601342163 -3.05982068413 221.867218565 -0.812601342163 -3.06482068413 211.913916808 -0.812601342163 -3.06982068413 217.221233493 -0.812601342163 -3.07482068413 214.479913857 -0.812601342163 -3.07982068413 208.46450957 -0.812601342163 -3.08482068413 196.295171882 -0.812601342163 -3.08982068413 208.675152354 -0.812601342163 -3.09482068413 192.220776253 -0.812601342163 -3.09982068413 192.220776253 -0.812601342163 -3.10482068413 200.869670942 -0.812601342163 -3.10982068413 195.60706197 -0.812601342163 -3.11482068413 191.771044522 -0.812601342163 -3.11982068413 184.977520723 -0.812601342163 -3.12482068413 182.057758086 -0.812601342163 -3.12982068413 182.808640316 -0.812601342163 -3.13482068413 180.992334134 -0.812601342163 -3.13982068413 177.593216618 -0.812601342163 -3.14482068413 176.351399146 -0.812601342163 -3.14982068413 151.804009871 -0.812601342163 -3.15482068413 161.538808436 -0.812601342163 -3.15982068413 157.99105963 -0.812601342163 -3.16482068413 155.975537782 -0.812601342163 -3.16982068413 146.594867124 -0.812601342163 -3.17482068413 137.120678093 -0.812601342163 -3.17982068413 126.587718994 -0.812601342163 -3.18482068413 116.766078426 -0.812601342163 -3.18982068413 105.216601666 -0.812601342163 -3.19482068413 81.6293644361 -0.812601342163 -3.19982068413 78.1129294284 -0.812601342163 -3.20482068413 68.9826847429 -0.812601342163 -3.20982068413 55.9142135965 -0.812601342163 -3.21482068413 51.2936344537 -0.812601342163 -3.21982068413 48.7902678687 -0.812601342163 -3.22482068413 14.2974834715 -0.812601342163 -3.22982068413 15.5545687858 -0.812601342163 -3.23482068413 27.7083171726 -0.812601342163 -3.23982068413 -4.00526983738 -0.812601342163 -3.24482068413 -26.3203998047 -0.812601342163 -3.24982068413 -32.9500225011 -0.812601342163 -3.25482068413 -13.3142514444 -0.812601342163 -3.25982068413 -10.6069939352 -0.812601342163 -3.26482068413 -12.0672687435 -0.812601342163 -3.26982068413 -11.1850141536 -0.812601342163 -3.27482068413 -15.143750719 -0.812601342163 -3.27982068413 -25.3598589823 -0.812601342163 -3.28482068413 -29.5046148528 -0.812601342163 -3.28982068413 -41.161633647 -0.812601342163 -3.29482068413 -51.1263830793 -0.812601342163 -3.29982068413 -51.1263830793 -0.812601342163 -3.30482068413 -51.1263830793 -0.812601342163 -3.30982068413 -51.1263830793 -0.812601342163 -3.31482068413 -51.1263830793 -0.812601342163 -3.31982068413 -51.1263830793 -0.812601342163 -3.32482068413 -51.1263830793 -0.812601342163 -3.32982068413 -51.1263830793 -0.812601342163 -3.33482068413 -51.1263830793 -0.812601342163 -3.33982068413 -51.1263830793 -0.812601342163 -3.34482068413 -51.1263830793 -0.812601342163 -3.34982068413 -51.1263830793 -0.812601342163 -3.35482068413 -51.1263830793 -0.812601342163 -3.35982068413 -51.1263830793 -0.812601342163 -3.36482068413 -51.1263830793 -0.812601342163 -3.36982068413 -51.1263830793 -0.812601342163 -3.37482068413 -51.1263830793 -0.812601342163 -3.37982068413 -51.1263830793 -0.812601342163 -3.38482068413 -51.1263830793 -0.812601342163 -3.38982068413 -51.1263830793 -0.812601342163 -3.39482068413 -51.1263830793 -0.812601342163 -3.39982068413 -51.1263830793 -0.812601342163 -3.40482068413 -51.1263830793 -0.812601342163 -3.40982068413 -51.1263830793 -0.812601342163 -3.41482068413 -51.1263830793 -0.812601342163 -3.41982068413 -51.1263830793 -0.812601342163 -3.42482068413 -51.1263830793 -0.812601342163 -3.42982068413 -51.1263830793 -0.812601342163 -3.43482068413 -51.1263830793 -0.812601342163 -3.43982068413 -51.1263830793 -0.812601342163 -3.44482068413 -51.1263830793 -0.812601342163 -3.44982068413 -51.1263830793 -0.812601342163 -3.45482068413 -51.1263830793 -0.812601342163 -3.45982068413 -51.1263830793 -0.812601342163 -3.46482068413 -51.1263830793 -0.812601342163 -3.46982068413 -51.1263830793 -0.812601342163 -3.47482068413 -51.1263830793 -0.812601342163 -3.47982068413 -51.1263830793 -0.812601342163 -3.48482068413 -51.1263830793 -0.812601342163 -3.48982068413 -51.1263830793 -0.812601342163 -3.49482068413 -51.1263830793 -0.812601342163 -3.49982068413 -51.1263830793 -0.812601342163 -3.50482068413 -51.1263830793 -0.812601342163 -3.50982068413 -51.1263830793 -0.812601342163 -3.51482068413 -51.1263830793 -0.812601342163 -3.51982068413 -51.1263830793 -0.812601342163 -3.52482068413 -51.1263830793 -0.812601342163 -3.52982068413 -51.1263830793 -0.812601342163 -3.53482068413 -51.1263830793 -0.812601342163 -3.53982068413 -51.1263830793 -0.812601342163 -3.54482068413 -51.1263830793 -0.812601342163 -3.54982068413 -51.1263830793 -0.812601342163 -3.55482068413 -51.1263830793 -0.812601342163 -3.55982068413 -51.1263830793 -0.812601342163 -3.56482068413 -51.1263830793 -0.812601342163 -3.56982068413 -51.1263830793 -0.812601342163 -3.57482068413 -51.1263830793 -0.812601342163 -3.57982068413 -51.1263830793 -0.812601342163 -3.58482068413 -51.1263830793 -0.812601342163 -3.58982068413 -51.1263830793 -0.812601342163 -3.59482068413 -51.1263830793 -0.812601342163 -3.59982068413 -51.1263830793 -0.812601342163 -3.60482068413 -51.1263830793 -0.812601342163 -3.60982068413 -51.1263830793 -0.812601342163 -3.61482068413 -51.1263830793 -0.812601342163 -3.61982068413 -51.1263830793 -0.812601342163 -3.62482068413 -51.1263830793 -0.812601342163 -3.62982068413 -51.1263830793 -0.812601342163 -3.63482068413 -51.1263830793 -0.812601342163 -3.63982068413 -51.1263830793 -0.812601342163 -3.64482068413 -51.1263830793 -0.812601342163 -3.64982068413 -51.1263830793 -0.812601342163 -3.65482068413 -51.1263830793 -0.812601342163 -3.65982068413 -51.1263830793 -0.812601342163 -3.66482068413 -51.1263830793 -0.812601342163 -3.66982068413 -51.1263830793 -0.812601342163 -3.67482068413 -51.1263830793 -0.812601342163 -3.67982068413 -51.1263830793 -0.812601342163 -3.68482068413 -51.1263830793 -0.812601342163 -3.68982068413 -51.1263830793 -0.812601342163 -3.69482068413 -51.1263830793 -0.812601342163 -3.69982068413 -51.1263830793 -0.812601342163 -3.70482068413 -51.1263830793 -0.812601342163 -3.70982068413 -51.1263830793 -0.812601342163 -3.71482068413 -51.1263830793 -0.812601342163 -3.71982068413 -51.1263830793 -0.812601342163 -3.72482068413 -51.1263830793 -0.812601342163 -3.72982068413 -51.1263830793 -0.812601342163 -3.73482068413 -51.1263830793 -0.812601342163 -3.73982068413 -51.1263830793 -0.812601342163 -3.74482068413 -51.1263830793 -0.812601342163 -3.74982068413 -51.1263830793 -0.812601342163 -3.75482068413 -51.1263830793 -0.812601342163 -3.75982068413 -51.1263830793 -0.812601342163 -3.76482068413 -51.1263830793 -0.812601342163 -3.76982068413 -51.1263830793 -0.812601342163 -3.77482068413 -51.1263830793 -0.812601342163 -3.77982068413 -51.1263830793 -0.812601342163 -3.78482068413 -51.1263830793 -0.812601342163 -3.78982068413 -51.1263830793 -0.812601342163 -3.79482068413 -51.1263830793 -0.812601342163 -3.79982068413 -51.1263830793 -0.812601342163 -3.80482068413 -51.1263830793 -0.812601342163 -3.80982068413 -51.1263830793 -0.812601342163 -3.81482068413 -51.1263830793 -0.812601342163 -3.81982068413 -51.1263830793 -0.812601342163 -3.82482068413 -51.1263830793 -0.812601342163 -3.82982068413 -51.1263830793 -0.812601342163 -3.83482068413 -51.1263830793 -0.812601342163 -3.83982068413 -51.1263830793 -0.812601342163 -3.84482068413 -51.1263830793 -0.812601342163 -3.84982068413 -51.1263830793 -0.812601342163 -3.85482068413 -51.1263830793 -0.812601342163 -3.85982068413 -51.1263830793 -0.812601342163 -3.86482068413 -51.1263830793 -0.812601342163 -3.86982068413 -51.1263830793 -0.812601342163 -3.87482068413 -51.1263830793 -0.812601342163 -3.87982068413 -51.1263830793 -0.812601342163 -3.88482068413 -51.1263830793 -0.812601342163 -3.88982068413 -51.1263830793 -0.812601342163 -3.89482068413 -51.1263830793 -0.812601342163 -3.89982068413 -51.1263830793 -0.812601342163 -3.90482068413 -51.1263830793 -0.812601342163 -3.90982068413 -51.1263830793 -0.812601342163 -3.91482068413 -51.1263830793 -0.812601342163 -3.91982068413 -51.1263830793 -0.812601342163 -3.92482068413 -51.1263830793 -0.812601342163 -3.92982068413 -51.1263830793 -0.812601342163 -3.93482068413 -51.1263830793 -0.812601342163 -3.93982068413 -51.1263830793 -0.812601342163 -3.94482068413 -51.1263830793 -0.812601342163 -3.94982068413 -51.1263830793 -0.812601342163 -3.95482068413 -51.1263830793 -0.812601342163 -3.95982068413 -51.1263830793 -0.812601342163 -3.96482068413 -51.1263830793 -0.812601342163 -3.96982068413 -51.1263830793 -0.812601342163 -3.97482068413 -51.1263830793 -0.812601342163 -3.97982068413 -51.1263830793 -0.812601342163 -3.98482068413 -51.1263830793 -0.812601342163 -3.98982068413 -51.1263830793 -0.812601342163 -3.99482068413 -51.1263830793 -0.812601342163 -3.99982068413 -51.1263830793 -0.812601342163 -4.00482068413 -51.1263830793 -0.812601342163 -4.00982068413 -51.1263830793 -0.812601342163 -4.01482068413 -51.1263830793 -0.812601342163 -4.01982068413 -51.1263830793 -0.812601342163 -4.02482068413 -51.1263830793 -0.812601342163 -4.02982068413 -51.1263830793 -0.812601342163 -4.03482068413 -51.1263830793 -0.812601342163 -4.03982068413 -51.1263830793 -0.812601342163 -4.04482068413 -51.1263830793 -0.812601342163 -4.04982068413 -51.1263830793 -0.812601342163 -4.05482068413 -51.1263830793 -0.812601342163 -4.05982068413 -51.1263830793 -0.812601342163 -4.06482068413 -51.1263830793 -0.812601342163 -4.06982068413 -51.1263830793 -0.812601342163 -4.07482068413 -51.1263830793 -0.812601342163 -4.07982068413 -51.1263830793 -0.812601342163 -4.08482068413 -51.1263830793 -0.812601342163 -4.08982068413 -51.1263830793 -0.812601342163 -4.09482068413 -51.1263830793 -0.812601342163 -4.09982068413 -51.1263830793 -0.812601342163 -4.10482068413 -51.1263830793 -0.812601342163 -4.10982068413 -51.1263830793 -0.812601342163 -4.11482068413 -51.1263830793 -0.812601342163 -4.11982068413 -51.1263830793 -0.812601342163 -4.12482068413 -51.1263830793 -0.812601342163 -4.12982068413 -51.1263830793 -0.812601342163 -4.13482068413 -51.1263830793 -0.812601342163 -4.13982068413 -51.1263830793 -0.812601342163 -4.14482068413 -51.1263830793 -0.812601342163 -4.14982068413 -51.1263830793 -0.812601342163 -4.15482068413 -51.1263830793 -0.812601342163 -4.15982068413 -51.1263830793 -0.812601342163 -4.16482068413 -51.1263830793 -0.812601342163 -4.16982068413 -51.1263830793 -0.812601342163 -4.17482068413 -51.1263830793 -0.812601342163 -4.17982068413 -51.1263830793 -0.812601342163 -4.18482068413 -51.1263830793 -0.812601342163 -4.18982068413 -51.1263830793 -0.812601342163 -4.19482068413 -51.1263830793 -0.812601342163 -4.19982068413 -51.1263830793 -0.812601342163 -4.20482068413 -51.1263830793 -0.812601342163 -4.20982068413 -51.1263830793 -0.812601342163 -4.21482068413 -51.1263830793 -0.812601342163 -4.21982068413 -51.1263830793 -0.812601342163 -4.22482068413 -51.1263830793 -0.812601342163 -4.22982068413 -51.1263830793 -0.812601342163 -4.23482068413 -51.1263830793 -0.812601342163 -4.23982068413 -51.1263830793 -0.812601342163 -4.24482068413 -51.1263830793 -0.812601342163 -4.24982068413 1445.20336292 -0.812601342163 -4.25482068413 1152.84499848 -0.812601342163 -4.25982068413 651.237870482 -0.812601342163 -4.26482068413 1047.50453085 -0.812601342163 -4.26982068413 1041.98236968 -0.812601342163 -4.27482068413 1146.33432175 -0.812601342163 -4.27982068413 1027.690092 -0.812601342163 -4.28482068413 1156.84302184 -0.812601342163 -4.28982068413 1170.3296138 -0.812601342163 -4.29482068413 1136.81132664 -0.812601342163 -4.29982068413 989.362238357 -0.812601342163 -4.30482068413 905.125382027 -0.812601342163 -4.30982068413 841.256393338 -0.812601342163 -4.31482068413 757.437361609 -0.812601342163 -4.31982068413 672.575605189 -0.812601342163 -4.32482068413 602.349260849 -0.812601342163 -4.32982068413 555.25403111 -0.812601342163 -4.33482068413 523.928748769 -0.812601342163 -4.33982068413 499.432140027 -0.812601342163 -4.34482068413 476.02565893 -0.812601342163 -4.34982068413 476.310918203 -0.812601342163 -4.35482068413 485.621713116 -0.812601342163 -4.35982068413 503.768251543 -0.812601342163 -4.36482068413 517.775822936 -0.812601342163 -4.36982068413 538.284456358 -0.812601342163 -4.37482068413 562.581424807 -0.812601342163 -4.37982068413 579.969263855 5.11408436183 -4.38482068413 597.355188756 5.11408436183 -4.38982068413 611.572741116 5.11408436183 -4.39482068413 620.911529327 5.11408436183 -4.39982068413 628.205441693 5.11408436183 -4.40482068413 630.996699616 5.11408436183 -4.40982068413 626.699897164 5.11408436183 -4.41482068413 622.43375913 5.11408436183 -4.41982068413 615.128411248 5.11408436183 -4.42482068413 608.528611396 5.11408436183 -4.42982068413 601.301166806 5.11408436183 -4.43482068413 590.473091194 5.11408436183 -4.43982068413 581.814882764 5.11408436183 -4.44482068413 574.316652634 5.11408436183 -4.44982068413 569.371088571 5.11408436183 -4.45482068413 567.154424795 5.11408436183 -4.45982068413 567.155218213 5.11408436183 -4.46482068413 567.942979052 5.11408436183 -4.46982068413 570.63611492 5.11408436183 -4.47482068413 576.109268725 5.11408436183 -4.47982068413 584.39035475 5.11408436183 -4.48482068413 595.230054502 5.11408436183 -4.48982068413 608.785737498 5.11408436183 -4.49482068413 622.735602577 5.11408436183 -4.49982068413 638.999488932 5.11408436183 -4.50482068413 656.597323879 5.11408436183 -4.50982068413 675.004753263 5.11408436183 -4.51482068413 693.025534456 5.11408436183 -4.51982068413 713.321010408 5.11408436183 -4.52482068413 728.89604117 5.11408436183 -4.52982068413 746.857968401 5.11408436183 -4.53482068413 763.027096247 5.11408436183 -4.53982068413 775.614290206 5.11408436183 -4.54482068413 790.698604507 5.11408436183 -4.54982068413 807.924631794 5.11408436183 -4.55482068413 832.495019226 5.11408436183 -4.55982068413 844.6902956 5.11408436183 -4.56482068413 865.114834613 5.11408436183 -4.56982068413 883.577233218 5.11408436183 -4.57482068413 892.156005366 5.11408436183 -4.57982068413 921.208938729 5.11408436183 -4.58482068413 941.215605234 5.11408436183 -4.58982068413 947.484901647 5.11408436183 -4.59482068413 959.332617647 5.11408436183 -4.59982068413 965.523884961 5.11408436183 -4.60482068413 944.392110598 5.11408436183 -4.60982068413 929.050786146 5.11408436183 -4.61482068413 888.445028085 5.11408436183 -4.61982068413 910.64415944 5.11408436183 -4.62482068413 871.606684429 5.11408436183 -4.62982068413 849.329538438 5.11408436183 -4.63482068413 800.966256697 5.11408436183 -4.63982068413 746.358603726 5.11408436183 -4.64482068413 738.984828846 -0.527519427038 -4.64982068413 674.82817629 -0.715180919622 -4.65482068413 647.516153784 -0.715180919622 -4.65982068413 664.976255481 -0.715180919622 -4.66482068413 630.279457202 -0.715180919622 -4.66982068413 599.344391554 -0.715180919622 -4.67482068413 563.902642937 -0.715180919622 -4.67982068413 541.818619752 -0.715180919622 -4.68482068413 493.20017721 -0.715180919622 -4.68982068413 454.783278955 -0.715180919622 -4.69482068413 435.498242612 -0.715180919622 -4.69982068413 400.416845026 -0.715180919622 -4.70482068413 364.188366509 -0.715180919622 -4.70982068413 321.276757819 -0.715180919622 -4.71482068413 299.618624206 -0.715180919622 -4.71982068413 282.886467692 -0.715180919622 -4.72482068413 267.164598831 -0.715180919622 -4.72982068413 257.251629141 -0.715180919622 -4.73482068413 252.296440115 -0.715180919622 -4.73982068413 255.126529446 -0.715180919622 -4.74482068413 258.49680416 -0.715180919622 -4.74982068413 264.21947988 -0.715180919622 -4.75482068413 454.276391148 -0.715180919622 -4.75982068413 414.420399285 -0.715180919622 -4.76482068413 355.392100979 -0.715180919622 -4.76982068413 324.608305033 -0.715180919622 -4.77482068413 287.633773667 -0.715180919622 -4.77982068413 247.222388988 -0.715180919622 -4.78482068413 229.536774776 -0.715180919622 -4.78982068413 241.383760025 -0.715180919622 -4.79482068413 270.055240548 -0.715180919622 -4.79982068413 286.891426899 -0.715180919622 -4.80482068413 301.637189255 -0.715180919622 -4.80982068413 331.010861783 -0.715180919622 -4.81482068413 377.555606728 -0.715180919622 -4.81982068413 398.856685683 -0.715180919622 -4.82482068413 414.709870799 -0.715180919622 -4.82982068413 428.917060075 -0.715180919622 -4.83482068413 446.28157022 -0.715180919622 -4.83982068413 460.198479135 -0.715180919622 -4.84482068413 463.743837232 -0.715180919622 -4.84982068413 459.575237516 -0.715180919622 -4.85482068413 465.178113785 -0.715180919622 -4.85982068413 457.38096384 -0.715180919622 -4.86482068413 451.292997838 -0.715180919622 -4.86982068413 437.419628451 -0.715180919622 -4.87482068413 424.909444064 -0.715180919622 -4.87982068413 411.696601405 -0.715180919622 -4.88482068413 378.985693751 -0.715180919622 -4.88982068413 362.189709341 -0.715180919622 -4.89482068413 347.606233484 -0.715180919622 -4.89982068413 324.661657212 -0.715180919622 -4.90482068413 312.764107745 -0.715180919622 -4.90982068413 295.879307794 -0.715180919622 -4.91482068413 294.268226724 -0.715180919622 -4.91982068413 290.22286348 -0.715180919622 -4.92482068413 298.436286919 -0.715180919622 -4.92982068413 298.371820438 -0.715180919622 -4.93482068413 319.093233114 -0.715180919622 -4.93982068413 314.521857891 -0.715180919622 -4.94482068413 309.646256218 -0.715180919622 -4.94982068413 323.222848901 -0.715180919622 -4.95482068413 316.359261383 -0.715180919622 -4.95982068413 314.377093285 -0.715180919622 -4.96482068413 319.098828483 -0.715180919622 -4.96982068413 321.667620009 -0.715180919622 -4.97482068413 319.722873826 -0.715180919622 -4.97982068413 315.501410883 -0.715180919622 -4.98482068413 311.575879446 -0.715180919622 -4.98982068413 309.920895612 -0.715180919622 -4.99482068413 306.776860806 -0.715180919622 -4.99982068413 305.74869264 -0.715180919622 -5.00482068413 297.028093115 -0.715180919622 -5.00982068413 287.711454491 -0.715180919622 -5.01482068413 285.223071448 -0.715180919622 -5.01982068413 282.945366485 -0.715180919622 -5.02482068413 275.75820986 -0.715180919622 -5.02982068413 271.007635727 -0.715180919622 -5.03482068413 264.573342312 -0.715180919622 -5.03982068413 259.206345255 -0.715180919622 -5.04482068413 252.103679796 -0.715180919622 -5.04982068413 244.81161743 -0.715180919622 -5.05482068413 237.729868872 -0.715180919622 -5.05982068413 232.829505971 -0.715180919622 -5.06482068413 223.356910396 -0.715180919622 -5.06982068413 218.951003845 -0.715180919622 -5.07482068413 212.375567002 -0.715180919622 -5.07982068413 208.598988401 -0.715180919622 -5.08482068413 201.627312167 -0.715180919622 -5.08982068413 191.7443439 -0.715180919622 -5.09482068413 181.4153356 -0.715180919622 -5.09982068413 171.818396119 -0.715180919622 -5.10482068413 161.147305744 -0.715180919622 -5.10982068413 151.552117113 -0.715180919622 -5.11482068413 139.126361433 -0.715180919622 -5.11982068413 128.05866902 -0.715180919622 -5.12482068413 114.559580547 -0.715180919622 -5.12982068413 104.396259497 -0.715180919622 -5.13482068413 96.5480362421 -0.715180919622 -5.13982068413 86.7267570046 -0.715180919622 -5.14482068413 69.4707393481 -0.715180919622 -5.14982068413 58.1366734504 -0.715180919622 -5.15482068413 47.7793786325 -0.715180919622 -5.15982068413 39.0959929379 -0.715180919622 -5.16482068413 30.0283487512 -0.715180919622 -5.16982068413 22.5147922669 -0.715180919622 -5.17482068413 12.3101834572 -0.715180919622 -5.17982068413 7.50875357407 -0.715180919622 -5.18482068413 0.0355802160609 -0.715180919622 -5.18982068413 -6.1369233105 -0.715180919622 -5.19482068413 -11.1319676574 -0.715180919622 -5.19982068413 -14.7858727187 -0.715180919622 -5.20482068413 -18.12173235 -0.715180919622 -5.20982068413 -23.9920997213 -0.715180919622 -5.21482068413 -34.6969591209 -0.715180919622 -5.21982068413 -42.0974104649 -0.715180919622 -5.22482068413 -51.6218321181 -0.715180919622 -5.22982068413 -59.5076953776 -0.715180919622 -5.23482068413 -59.5076953776 -0.715180919622 -5.23982068413 -59.5076953776 -0.715180919622 -5.24482068413 -59.5076953776 -0.715180919622 -5.24982068413 -59.5076953776 -0.715180919622 -5.25482068413 -59.5076953776 -0.715180919622 -5.25982068413 -59.5076953776 -0.715180919622 -5.26482068413 -59.5076953776 -0.715180919622 -5.26982068413 -59.5076953776 -0.715180919622 -5.27482068413 -59.5076953776 -0.715180919622 -5.27982068413 -59.5076953776 -0.715180919622 -5.28482068413 -59.5076953776 -0.715180919622 -5.28982068413 -59.5076953776 -0.715180919622 -5.29482068413 -59.5076953776 -0.715180919622 -5.29982068413 -59.5076953776 -0.715180919622 -5.30482068413 -59.5076953776 -0.715180919622 -5.30982068413 -59.5076953776 -0.715180919622 -5.31482068413 -59.5076953776 -0.715180919622 -5.31982068413 -59.5076953776 -0.715180919622 -5.32482068413 -59.5076953776 -0.715180919622 -5.32982068413 -59.5076953776 -0.715180919622 -5.33482068413 -59.5076953776 -0.715180919622 -5.33982068413 -59.5076953776 -0.715180919622 -5.34482068413 -59.5076953776 -0.715180919622 -5.34982068413 -59.5076953776 -0.715180919622 -5.35482068413 -59.5076953776 -0.715180919622 -5.35982068413 -59.5076953776 -0.715180919622 -5.36482068413 -59.5076953776 -0.715180919622 -5.36982068413 -59.5076953776 -0.715180919622 -5.37482068413 -59.5076953776 -0.715180919622 -5.37982068413 -59.5076953776 -0.715180919622 -5.38482068413 -59.5076953776 -0.715180919622 -5.38982068413 -59.5076953776 -0.715180919622 -5.39482068413 -59.5076953776 -0.715180919622 -5.39982068413 -59.5076953776 -0.715180919622 -5.40482068413 -59.5076953776 -0.715180919622 -5.40982068413 -59.5076953776 -0.715180919622 -5.41482068413 -59.5076953776 -0.715180919622 -5.41982068413 -59.5076953776 -0.715180919622 -5.42482068413 -59.5076953776 -0.715180919622 -5.42982068413 -59.5076953776 -0.715180919622 -5.43482068413 -59.5076953776 -0.715180919622 -5.43982068413 -59.5076953776 -0.715180919622 -5.44482068413 -59.5076953776 -0.715180919622 -5.44982068413 -59.5076953776 -0.715180919622 -5.45482068413 -59.5076953776 -0.715180919622 -5.45982068413 -59.5076953776 -0.715180919622 -5.46482068413 -59.5076953776 -0.715180919622 -5.46982068413 -59.5076953776 -0.715180919622 -5.47482068413 -59.5076953776 -0.715180919622 -5.47982068413 -59.5076953776 -0.715180919622 -5.48482068413 -59.5076953776 -0.715180919622 -5.48982068413 -59.5076953776 -0.715180919622 -5.49482068413 -59.5076953776 -0.715180919622 -5.49982068413 -59.5076953776 -0.715180919622 -5.50482068413 -59.5076953776 -0.715180919622 -5.50982068413 -59.5076953776 -0.715180919622 -5.51482068413 -59.5076953776 -0.715180919622 -5.51982068413 -59.5076953776 -0.715180919622 -5.52482068413 -59.5076953776 -0.715180919622 -5.52982068413 -59.5076953776 -0.715180919622 -5.53482068413 -59.5076953776 -0.715180919622 -5.53982068413 -59.5076953776 -0.715180919622 -5.54482068413 -59.5076953776 -0.715180919622 -5.54982068413 -59.5076953776 -0.715180919622 -5.55482068413 -59.5076953776 -0.715180919622 -5.55982068413 -59.5076953776 -0.715180919622 -5.56482068413 -59.5076953776 -0.715180919622 -5.56982068413 -59.5076953776 -0.715180919622 -5.57482068413 -59.5076953776 -0.715180919622 -5.57982068413 -59.5076953776 -0.715180919622 -5.58482068413 -59.5076953776 -0.715180919622 -5.58982068413 -59.5076953776 -0.715180919622 -5.59482068413 -59.5076953776 -0.715180919622 -5.59982068413 -59.5076953776 -0.715180919622 -5.60482068413 -59.5076953776 -0.715180919622 -5.60982068413 -59.5076953776 -0.715180919622 -5.61482068413 -59.5076953776 -0.715180919622 -5.61982068413 -59.5076953776 -0.715180919622 -5.62482068413 -59.5076953776 -0.715180919622 -5.62982068413 -59.5076953776 -0.715180919622 -5.63482068413 -59.5076953776 -0.715180919622 -5.63982068413 -59.5076953776 -0.715180919622 -5.64482068413 -59.5076953776 -0.715180919622 -5.64982068413 -59.5076953776 -0.715180919622 -5.65482068413 -59.5076953776 -0.715180919622 -5.65982068413 -59.5076953776 -0.715180919622 -5.66482068413 -59.5076953776 -0.715180919622 -5.66982068413 -59.5076953776 -0.715180919622 -5.67482068413 -59.5076953776 -0.715180919622 -5.67982068413 -59.5076953776 -0.715180919622 -5.68482068413 -59.5076953776 -0.715180919622 -5.68982068413 -59.5076953776 -0.715180919622 -5.69482068413 -59.5076953776 -0.715180919622 -5.69982068413 -59.5076953776 -0.715180919622 -5.70482068413 -59.5076953776 -0.715180919622 -5.70982068413 -59.5076953776 -0.715180919622 -5.71482068413 -59.5076953776 -0.715180919622 -5.71982068413 -59.5076953776 -0.715180919622 -5.72482068413 -59.5076953776 -0.715180919622 -5.72982068413 -59.5076953776 -0.715180919622 -5.73482068413 -59.5076953776 -0.715180919622 -5.73982068413 -59.5076953776 -0.715180919622 -5.74482068413 -59.5076953776 -0.715180919622 -5.74982068413 -59.5076953776 -0.715180919622 -5.75482068413 -59.5076953776 -0.715180919622 -5.75982068413 -59.5076953776 -0.715180919622 -5.76482068413 -59.5076953776 -0.715180919622 -5.76982068413 -59.5076953776 -0.715180919622 -5.77482068413 -59.5076953776 -0.715180919622 -5.77982068413 -59.5076953776 -0.715180919622 -5.78482068413 -59.5076953776 -0.715180919622 -5.78982068413 -59.5076953776 -0.715180919622 -5.79482068413 -59.5076953776 -0.715180919622 -5.79982068413 -59.5076953776 -0.715180919622 -5.80482068413 -59.5076953776 -0.715180919622 -5.80982068413 -59.5076953776 -0.715180919622 -5.81482068413 -59.5076953776 -0.715180919622 -5.81982068413 -59.5076953776 -0.715180919622 -5.82482068413 -59.5076953776 -0.715180919622 -5.82982068413 -59.5076953776 -0.715180919622 -5.83482068413 -59.5076953776 -0.715180919622 -5.83982068413 -59.5076953776 -0.715180919622 -5.84482068413 -59.5076953776 -0.715180919622 -5.84982068413 -59.5076953776 -0.715180919622 -5.85482068413 -59.5076953776 -0.715180919622 -5.85982068413 -59.5076953776 -0.715180919622 -5.86482068413 -59.5076953776 -0.715180919622 -5.86982068413 -59.5076953776 -0.715180919622 -5.87482068413 -59.5076953776 -0.715180919622 -5.87982068413 -59.5076953776 -0.715180919622 -5.88482068413 -59.5076953776 -0.715180919622 -5.88982068413 -59.5076953776 -0.715180919622 -5.89482068413 -59.5076953776 -0.715180919622 -5.89982068413 -59.5076953776 -0.715180919622 -5.90482068413 -59.5076953776 -0.715180919622 -5.90982068413 -59.5076953776 -0.715180919622 -5.91482068413 -59.5076953776 -0.715180919622 -5.91982068413 -59.5076953776 -0.715180919622 -5.92482068413 -59.5076953776 -0.715180919622 -5.92982068413 -59.5076953776 -0.715180919622 -5.93482068413 -59.5076953776 -0.715180919622 -5.93982068413 -59.5076953776 -0.715180919622 -5.94482068413 -59.5076953776 -0.715180919622 -5.94982068413 -59.5076953776 -0.715180919622 -5.95482068413 -59.5076953776 -0.715180919622 -5.95982068413 -59.5076953776 -0.715180919622 -5.96482068413 -59.5076953776 -0.715180919622 -5.96982068413 -59.5076953776 -0.715180919622 -5.97482068413 -59.5076953776 -0.715180919622 -5.97982068413 -59.5076953776 -0.715180919622 -5.98482068413 -59.5076953776 -0.715180919622 -5.98982068413 -59.5076953776 -0.715180919622 -5.99482068413 -59.5076953776 -0.715180919622 -5.99982068413 -59.5076953776 -0.715180919622 -6.00482068413 -59.5076953776 -0.715180919622 -6.00982068413 -59.5076953776 -0.715180919622 -6.01482068413 -59.5076953776 -0.715180919622 -6.01982068413 -59.5076953776 -0.715180919622 -6.02482068413 -59.5076953776 -0.715180919622 -6.02982068413 -59.5076953776 -0.715180919622 -6.03482068413 -59.5076953776 -0.715180919622 -6.03982068413 -59.5076953776 -0.715180919622 -6.04482068413 -59.5076953776 -0.715180919622 -6.04982068413 -59.5076953776 -0.715180919622 -6.05482068413 -59.5076953776 -0.715180919622 -6.05982068413 -59.5076953776 -0.715180919622 -6.06482068413 -59.5076953776 -0.715180919622 -6.06982068413 -59.5076953776 -0.715180919622 -6.07482068413 -59.5076953776 -0.715180919622 -6.07982068413 -59.5076953776 -0.715180919622 -6.08482068413 -59.5076953776 -0.715180919622 -6.08982068413 -59.5076953776 -0.715180919622 -6.09482068413 -59.5076953776 -0.715180919622 -6.09982068413 -59.5076953776 -0.715180919622 -6.10482068413 -59.5076953776 -0.715180919622 -6.10982068413 -59.5076953776 -0.715180919622 -6.11482068413 -59.5076953776 -0.715180919622 -6.11982068413 -59.5076953776 -0.715180919622 -6.12482068413 -59.5076953776 -0.715180919622 -6.12982068413 -59.5076953776 -0.715180919622 -6.13482068413 -59.5076953776 -0.715180919622 -6.13982068413 -59.5076953776 -0.715180919622 -6.14482068413 -59.5076953776 -0.715180919622 -6.14982068413 -59.5076953776 -0.715180919622 -6.15482068413 -59.5076953776 -0.715180919622 -6.15982068413 798.554606778 -0.715180919622 -6.16482068413 328.268727495 -0.715180919622 -6.16982068413 132.201194315 -0.715180919622 -6.17482068413 -219.099856507 -0.715180919622 -6.17982068413 92.6985531346 -0.715180919622 -6.18482068413 870.388117863 -0.715180919622 -6.18982068413 1704.01686569 -0.715180919622 -6.19482068413 1779.71198768 -0.715180919622 -6.19982068413 1543.21700339 -0.715180919622 -6.20482068413 1361.75423663 -0.715180919622 -6.20982068413 1014.43180956 -0.715180919622 -6.21482068413 1033.57701216 -0.715180919622 -6.21982068413 810.426930861 -0.715180919622 -6.22482068413 634.910954651 -0.715180919622 -6.22982068413 579.5941707 -0.715180919622 -6.23482068413 493.454331288 -0.715180919622 -6.23982068413 465.778744655 -0.715180919622 -6.24482068413 428.641431138 -0.715180919622 -6.24982068413 412.767221818 -0.715180919622 -6.25482068413 434.142577376 -0.715180919622 -6.25982068413 478.266947584 -0.715180919622 -6.26482068413 504.880840536 -0.715180919622 -6.26982068413 519.510410012 -0.715180919622 -6.27482068413 524.21112833 -0.715180919622 -6.27982068413 544.923050991 -0.715180919622 -6.28482068413 548.160537438 -0.715180919622 -6.28982068413 537.911221811 -0.715180919622 -6.29482068413 551.012031793 -0.715180919622 -6.29982068413 552.586244559 -0.715180919622 -6.30482068413 561.266542485 -0.715180919622 -6.30982068413 565.722318028 -0.715180919622 -6.31482068413 572.541827038 -0.715180919622 -6.31982068413 515.668730721 -0.715180919622 -6.32482068413 551.681298836 -0.715180919622 -6.32982068413 558.366616579 -0.715180919622 -6.33482068413 570.812749876 -0.715180919622 -6.33982068413 583.435269931 -0.715180919622 -6.34482068413 592.399151743 -0.715180919622 -6.34982068413 598.064761356 -0.715180919622 -6.35482068413 600.034497482 -0.715180919622 -6.35982068413 600.989944602 -0.715180919622 -6.36482068413 600.229809891 -0.715180919622 -6.36982068413 595.222370139 -0.715180919622 -6.37482068413 592.016457221 -0.715180919622 -6.37982068413 587.85454356 -0.715180919622 -6.38482068413 583.029657182 -0.715180919622 -6.38982068413 578.952390404 -0.715180919622 -6.39482068413 572.351105671 -0.715180919622 -6.39982068413 569.070074268 -0.715180919622 -6.40482068413 569.697491957 -0.715180919622 -6.40982068413 570.433530621 -0.715180919622 -6.41482068413 575.126832712 -0.715180919622 -6.41982068413 585.8327573 -0.715180919622 -6.42482068413 597.433604726 -0.715180919622 -6.42982068413 610.327958872 -0.715180919622 -6.43482068413 625.545861808 -0.715180919622 -6.43982068413 640.081671634 -0.715180919622 -6.44482068413 656.931963111 -0.715180919622 -6.44982068413 675.859399844 -0.715180919622 -6.45482068413 690.822910963 -0.715180919622 -6.45982068413 710.464741221 -0.715180919622 -6.46482068413 731.996962156 -0.715180919622 -6.46982068413 751.515202492 -0.715180919622 -6.47482068413 771.257365552 -0.715180919622 -6.47982068413 799.449820149 -0.715180919622 -6.48482068413 828.841457903 -0.715180919622 -6.48982068413 862.654907289 -0.715180919622 -6.49482068413 884.398483294 -0.715180919622 -6.49982068413 909.084074144 -0.715180919622 -6.50482068413 970.483381089 -0.715180919622 -6.50982068413 955.87084304 -0.715180919622 -6.51482068413 973.393062099 -0.715180919622 -6.51982068413 988.419405574 -0.715180919622 -6.52482068413 963.047203154 -0.715180919622 -6.52982068413 934.568657307 -0.715180919622 -6.53482068413 891.025511731 -0.715180919622 -6.53982068413 863.567364336 -0.715180919622 -6.54482068413 827.577015014 -0.715180919622 -6.54982068413 789.620910397 -0.715180919622 -6.55482068413 754.331720012 -0.715180919622 -6.55982068413 706.451791091 -0.715180919622 -6.56482068413 672.009325605 -0.715180919622 -6.56982068413 637.297547354 -0.715180919622 -6.57482068413 600.080198349 -0.715180919622 -6.57982068413 573.007434596 -0.715180919622 -6.58482068413 546.936894199 -0.715180919622 -6.58982068413 527.071917621 -0.715180919622 -6.59482068413 504.241438557 -0.715180919622 -6.59982068413 493.273095787 -0.715180919622 -6.60482068413 476.723266148 -0.715180919622 -6.60982068413 463.943734386 -0.715180919622 -6.61482068413 448.009335424 -0.715180919622 -6.61982068413 434.594747352 -0.715180919622 -6.62482068413 417.477767756 -0.715180919622 -6.62982068413 402.455065882 -0.715180919622 -6.63482068413 387.437591909 -0.715180919622 -6.63982068413 377.036044602 -0.715180919622 -6.64482068413 369.082374305 -0.715180919622 -6.64982068413 366.530588875 -0.715180919622 -6.65482068413 366.538602836 -0.715180919622 -6.65982068413 378.426711398 -0.715180919622 -6.66482068413 385.409900414 -0.715180919622 -6.66982068413 389.148170696 -0.715180919622 -6.67482068413 391.30984959 -0.715180919622 -6.67982068413 395.457781685 -0.715180919622 -6.68482068413 399.304538984 -0.715180919622 -6.68982068413 402.725400626 -0.715180919622 -6.69482068413 406.900569499 -0.715180919622 -6.69982068413 410.365981537 -0.715180919622 -6.70482068413 411.375708165 -0.715180919622 -6.70982068413 414.224470892 -0.715180919622 -6.71482068413 423.789901963 -0.715180919622 -6.71982068413 420.496795949 -0.715180919622 -6.72482068413 416.795022644 -0.715180919622 -6.72982068413 413.52543652 -0.715180919622 -6.73482068413 411.470226085 -0.715180919622 -6.73982068413 414.495323529 -0.715180919622 -6.74482068413 418.659851792 -0.715180919622 -6.74982068413 423.148073706 -0.715180919622 -6.75482068413 421.920813797 -0.715180919622 -6.75982068413 424.128303674 -0.715180919622 -6.76482068413 425.958756011 -0.715180919622 -6.76982068413 426.1178486 -0.715180919622 -6.77482068413 417.053116194 -0.715180919622 -6.77982068413 411.184939813 -0.715180919622 -6.78482068413 417.141091811 -0.715180919622 -6.78982068413 408.603136189 -0.715180919622 -6.79482068413 403.487146518 -0.715180919622 -6.79982068413 400.031338763 -0.715180919622 -6.80482068413 391.589044987 -0.715180919622 -6.80982068413 385.985355896 -0.715180919622 -6.81482068413 381.528956743 -0.715180919622 -6.81982068413 374.57995478 -0.715180919622 -6.82482068413 371.108444643 -0.715180919622 -6.82982068413 365.376213539 -0.715180919622 -6.83482068413 362.908495269 -0.715180919622 -6.83982068413 361.663494329 -0.715180919622 -6.84482068413 361.970891714 -0.715180919622 -6.84982068413 359.616383678 -0.715180919622 -6.85482068413 356.491306215 -0.715180919622 -6.85982068413 354.998913962 -0.715180919622 -6.86482068413 355.341795245 -0.715180919622 -6.86982068413 357.108332874 -0.715180919622 -6.87482068413 355.575477083 -0.715180919622 -6.87982068413 350.834099838 -0.715180919622 -6.88482068413 350.550460757 -0.715180919622 -6.88982068413 347.184002176 -0.715180919622 -6.89482068413 345.512973735 -0.715180919622 -6.89982068413 339.265723323 -0.715180919622 -6.90482068413 335.378918557 -0.715180919622 -6.90982068413 332.704751962 -0.715180919622 -6.91482068413 328.509266186 -0.715180919622 -6.91982068413 322.463712069 -0.715180919622 -6.92482068413 316.744502245 -0.715180919622 -6.92982068413 312.038575141 -0.715180919622 -6.93482068413 305.682637686 -0.715180919622 -6.93982068413 299.050309382 -0.715180919622 -6.94482068413 293.215671826 -0.715180919622 -6.94982068413 288.760531197 -0.715180919622 -6.95482068413 286.328202983 -0.715180919622 -6.95982068413 281.1822825 -0.715180919622 -6.96482068413 274.646778248 -0.715180919622 -6.96982068413 266.602716534 -0.715180919622 -6.97482068413 256.868913736 -0.715180919622 -6.97982068413 248.664771384 -0.715180919622 -6.98482068413 239.076035965 -0.715180919622 -6.98982068413 226.60946587 -0.715180919622 -6.99482068413 221.078823356 -0.715180919622 -6.99982068413 213.25705241 -0.715180919622 -7.00482068413 205.205540186 -0.715180919622 -7.00982068413 195.751463085 -0.715180919622 -7.01482068413 186.996894246 -0.715180919622 -7.01982068413 177.054331248 -0.715180919622 -7.02482068413 168.138870562 -0.715180919622 -7.02982068413 167.222827797 -0.715180919622 -7.03482068413 156.323137168 -0.715180919622 -7.03982068413 142.40266752 -0.715180919622 -7.04482068413 133.588558749 -0.715180919622 -7.04982068413 128.066524736 -0.715180919622 -7.05482068413 118.379855736 -0.715180919622 -7.05982068413 109.543385779 -0.715180919622 -7.06482068413 95.9281330351 -0.715180919622 -7.06982068413 84.9096412992 -0.715180919622 -7.07482068413 74.7442591127 -0.715180919622 -7.07982068413 62.7166537745 -0.715180919622 -7.08482068413 52.7922093481 -0.715180919622 -7.08982068413 44.542831759 -0.715180919622 -7.09482068413 18.1696176607 -0.715180919622 -7.09982068413 -18.9739394831 -0.715180919622 -7.10482068413 -19.3103103051 -0.715180919622 -7.10982068413 7.77301412559 -0.715180919622 -7.11482068413 15.2083151915 -0.715180919622 -7.11982068413 8.14955791665 -0.715180919622 -7.12482068413 -11.2799405419 -0.715180919622 -7.12982068413 -8.08182063526 -0.715180919622 -7.13482068413 -21.3125430884 -0.715180919622 -7.13982068413 -26.9820663755 -0.715180919622 -7.14482068413 -40.2985280955 -0.715180919622 -7.14982068413 -54.008232421 -0.715180919622 -7.15482068413 -54.008232421 -0.715180919622 -7.15982068413 -54.008232421 -0.715180919622 -7.16482068413 -54.008232421 -0.715180919622 -7.16982068413 -54.008232421 -0.715180919622 -7.17482068413 -54.008232421 -0.715180919622 -7.17982068413 -54.008232421 -0.715180919622 -7.18482068413 -54.008232421 -0.715180919622 -7.18982068413 -54.008232421 -0.715180919622 -7.19482068413 -54.008232421 -0.715180919622 -7.19982068413 -54.008232421 -0.715180919622 -7.20482068413 -54.008232421 -0.715180919622 -7.20982068413 -54.008232421 -0.715180919622 -7.21482068413 -54.008232421 -0.715180919622 -7.21982068413 -54.008232421 -0.715180919622 -7.22482068413 -54.008232421 -0.715180919622 -7.22982068413 -54.008232421 -0.715180919622 -7.23482068413 -54.008232421 -0.715180919622 -7.23982068413 -54.008232421 -0.715180919622 -7.24482068413 -54.008232421 -0.715180919622 -7.24982068413 -54.008232421 -0.715180919622 -7.25482068413 -54.008232421 -0.715180919622 -7.25982068413 -54.008232421 -0.715180919622 -7.26482068413 -54.008232421 -0.715180919622 -7.26982068413 -54.008232421 -0.715180919622 -7.27482068413 -54.008232421 -0.715180919622 -7.27982068413 -54.008232421 -0.715180919622 -7.28482068413 -54.008232421 -0.715180919622 -7.28982068413 -54.008232421 -0.715180919622 -7.29482068413 -54.008232421 -0.715180919622 -7.29982068413 -54.008232421 -0.715180919622 -7.30482068413 -54.008232421 -0.715180919622 -7.30982068413 -54.008232421 -0.715180919622 -7.31482068413 -54.008232421 -0.715180919622 -7.31982068413 -54.008232421 -0.715180919622 -7.32482068413 -54.008232421 -0.715180919622 -7.32982068413 -54.008232421 -0.715180919622 -7.33482068413 -54.008232421 -0.715180919622 -7.33982068413 -54.008232421 -0.715180919622 -7.34482068413 -54.008232421 -0.715180919622 -7.34982068413 -54.008232421 -0.715180919622 -7.35482068413 -54.008232421 -0.715180919622 -7.35982068413 -54.008232421 -0.715180919622 -7.36482068413 -54.008232421 -0.715180919622 -7.36982068413 -54.008232421 -0.715180919622 -7.37482068413 -54.008232421 -0.715180919622 -7.37982068413 -54.008232421 -0.715180919622 -7.38482068413 -54.008232421 -0.715180919622 -7.38982068413 -54.008232421 -0.715180919622 -7.39482068413 -54.008232421 -0.715180919622 -7.39982068413 -54.008232421 -0.715180919622 -7.40482068413 -54.008232421 -0.715180919622 -7.40982068413 -54.008232421 -0.715180919622 -7.41482068413 -54.008232421 -0.715180919622 -7.41982068413 -54.008232421 -0.715180919622 -7.42482068413 -54.008232421 -0.715180919622 -7.42982068413 -54.008232421 -0.715180919622 -7.43482068413 -54.008232421 -0.715180919622 -7.43982068413 -54.008232421 -0.715180919622 -7.44482068413 -54.008232421 -0.715180919622 -7.44982068413 -54.008232421 -0.715180919622 -7.45482068413 -54.008232421 -0.715180919622 -7.45982068413 -54.008232421 -0.715180919622 -7.46482068413 -54.008232421 -0.715180919622 -7.46982068413 -54.008232421 -0.715180919622 -7.47482068413 -54.008232421 -0.715180919622 -7.47982068413 -54.008232421 -0.715180919622 -7.48482068413 -54.008232421 -0.715180919622 -7.48982068413 -54.008232421 -0.715180919622 -7.49482068413 -54.008232421 -0.715180919622 -7.49982068413 -54.008232421 -0.715180919622 -7.50482068413 -54.008232421 -0.715180919622 -7.50982068413 -54.008232421 -0.715180919622 -7.51482068413 -54.008232421 -0.715180919622 -7.51982068413 -54.008232421 -0.715180919622 -7.52482068413 -54.008232421 -0.715180919622 -7.52982068413 -54.008232421 -0.715180919622 -7.53482068413 -54.008232421 -0.715180919622 -7.53982068413 -54.008232421 -0.715180919622 -7.54482068413 -54.008232421 -0.715180919622 -7.54982068413 -54.008232421 -0.715180919622 -7.55482068413 -54.008232421 -0.715180919622 -7.55982068413 -54.008232421 -0.715180919622 -7.56482068413 -54.008232421 -0.715180919622 -7.56982068413 -54.008232421 -0.715180919622 -7.57482068413 -54.008232421 -0.715180919622 -7.57982068413 -54.008232421 -0.715180919622 -7.58482068413 -54.008232421 -0.715180919622 -7.58982068413 -54.008232421 -0.715180919622 -7.59482068413 -54.008232421 -0.715180919622 -7.59982068413 -54.008232421 -0.715180919622 -7.60482068413 -54.008232421 -0.715180919622 -7.60982068413 -54.008232421 -0.715180919622 -7.61482068413 -54.008232421 -0.715180919622 -7.61982068413 -54.008232421 -0.715180919622 -7.62482068413 -54.008232421 -0.715180919622 -7.62982068413 -54.008232421 -0.715180919622 -7.63482068413 -54.008232421 -0.715180919622 -7.63982068413 -54.008232421 -0.715180919622 -7.64482068413 -54.008232421 -0.715180919622 -7.64982068413 -54.008232421 -0.715180919622 -7.65482068413 -54.008232421 -0.715180919622 -7.65982068413 -54.008232421 -0.715180919622 -7.66482068413 -54.008232421 -0.715180919622 -7.66982068413 -54.008232421 -0.715180919622 -7.67482068413 -54.008232421 -0.715180919622 -7.67982068413 -54.008232421 -0.715180919622 -7.68482068413 -54.008232421 -0.715180919622 -7.68982068413 -54.008232421 -0.715180919622 -7.69482068413 -54.008232421 -0.715180919622 -7.69982068413 -54.008232421 -0.715180919622 -7.70482068413 -54.008232421 -0.715180919622 -7.70982068413 -54.008232421 -0.715180919622 -7.71482068413 -54.008232421 -0.715180919622 -7.71982068413 -54.008232421 -0.715180919622 -7.72482068413 -54.008232421 -0.715180919622 -7.72982068413 -54.008232421 -0.715180919622 -7.73482068413 -54.008232421 -0.715180919622 -7.73982068413 -54.008232421 -0.715180919622 -7.74482068413 -54.008232421 -0.715180919622 -7.74982068413 -54.008232421 -0.715180919622 -7.75482068413 -54.008232421 -0.715180919622 -7.75982068413 -54.008232421 -0.715180919622 -7.76482068413 -54.008232421 -0.715180919622 -7.76982068413 -54.008232421 -0.715180919622 -7.77482068413 -54.008232421 -0.715180919622 -7.77982068413 -54.008232421 -0.715180919622 -7.78482068413 -54.008232421 -0.715180919622 -7.78982068413 -54.008232421 -0.715180919622 -7.79482068413 -54.008232421 -0.715180919622 -7.79982068413 -54.008232421 -0.715180919622 -7.80482068413 -54.008232421 -0.715180919622 -7.80982068413 -54.008232421 -0.715180919622 -7.81482068413 -54.008232421 -0.715180919622 -7.81982068413 -54.008232421 -0.715180919622 -7.82482068413 -54.008232421 -0.715180919622 -7.82982068413 -54.008232421 -0.715180919622 -7.83482068413 -54.008232421 -0.715180919622 -7.83982068413 -54.008232421 -0.715180919622 -7.84482068413 -54.008232421 -0.715180919622 -7.84982068413 -54.008232421 -0.715180919622 -7.85482068413 -54.008232421 -0.715180919622 -7.85982068413 -54.008232421 -0.715180919622 -7.86482068413 -54.008232421 -0.715180919622 -7.86982068413 -54.008232421 -0.715180919622 -7.87482068413 -54.008232421 -0.715180919622 -7.87982068413 -54.008232421 -0.715180919622 -7.88482068413 -54.008232421 -0.715180919622 -7.88982068413 -54.008232421 -0.715180919622 -7.89482068413 -54.008232421 -0.715180919622 -7.89982068413 -54.008232421 -0.715180919622 -7.90482068413 -54.008232421 -0.715180919622 -7.90982068413 -54.008232421 -0.715180919622 -7.91482068413 -54.008232421 -0.715180919622 -7.91982068413 -54.008232421 -0.715180919622 -7.92482068413 -54.008232421 -0.715180919622 -7.92982068413 -54.008232421 -0.715180919622 -7.93482068413 -54.008232421 -0.715180919622 -7.93982068413 -54.008232421 -0.715180919622 -7.94482068413 -54.008232421 -0.715180919622 -7.94982068413 -54.008232421 -0.715180919622 -7.95482068413 -54.008232421 -0.715180919622 -7.95982068413 -54.008232421 -0.715180919622 -7.96482068413 -54.008232421 -0.715180919622 -7.96982068413 -54.008232421 -0.715180919622 -7.97482068413 -54.008232421 -0.715180919622 -7.97982068413 -54.008232421 -0.715180919622 -7.98482068413 -54.008232421 -0.715180919622 -7.98982068413 -54.008232421 -0.715180919622 -7.99482068413 -54.008232421 -0.715180919622 -7.99982068413 -54.008232421 -0.715180919622 -8.00482068413 -54.008232421 -0.715180919622 -8.00982068413 -54.008232421 -0.715180919622 -8.01482068413 -54.008232421 -0.715180919622 -8.01982068413 -54.008232421 -0.715180919622 -8.02482068413 -54.008232421 -0.715180919622 -8.02982068413 -54.008232421 -0.715180919622 -8.03482068413 -54.008232421 -0.715180919622 -8.03982068413 -54.008232421 -0.715180919622 -8.04482068413 -54.008232421 -0.715180919622 -8.04982068413 -54.008232421 -0.715180919622 -8.05482068413 -54.008232421 -0.715180919622 -8.05982068413 -54.008232421 -0.715180919622 -8.06482068413 -54.008232421 -0.715180919622 -8.06982068413 -54.008232421 -0.715180919622 -8.07482068413 -54.008232421 -0.715180919622 -8.07982068413 -54.008232421 -0.715180919622 -8.08482068413 -54.008232421 -0.715180919622 -8.08982068413 -54.008232421 -0.715180919622 -8.09482068413 -54.008232421 -0.715180919622 -8.09982068413 -54.008232421 -0.715180919622 -8.10482068413 -54.008232421 -0.715180919622 -8.10982068413 -54.008232421 -0.715180919622 -8.11482068413 -54.008232421 -0.715180919622 -8.11982068413 671.363126485 -0.715180919622 -8.12482068413 1675.19942355 -0.715180919622 -8.12982068413 2075.92418063 -0.715180919622 -8.13482068413 2330.34203385 -0.715180919622 -8.13982068413 2194.84206415 -0.715180919622 -8.14482068413 1888.33417594 -0.715180919622 -8.14982068413 1533.51623536 -0.715180919622 -8.15482068413 1285.32777571 -0.715180919622 -8.15982068413 1096.7798073 -0.715180919622 -8.16482068413 940.135449142 -0.715180919622 -8.16982068413 791.535399342 -0.715180919622 -8.17482068413 646.720309256 -0.715180919622 -8.17982068413 526.690241911 -0.715180919622 -8.18482068413 446.91833886 -0.715180919622 -8.18982068413 397.565028349 -0.715180919622 -8.19482068413 377.44633083 -0.715180919622 -8.19982068413 362.349510943 -0.715180919622 -8.20482068413 369.207886968 -0.715180919622 -8.20982068413 388.091209414 -0.715180919622 -8.21482068413 412.168930185 2.50667026049 -8.21982068413 443.045316104 2.51569154217 -8.22482068413 471.988054506 2.4815900928 -8.22982068413 497.59773814 2.4815900928 -8.23482068413 525.171010358 2.4815900928 -8.23982068413 551.519763078 2.4815900928 -8.24482068413 574.621550974 2.4815900928 -8.24982068413 587.881320121 2.4815900928 -8.25482068413 594.09093387 2.4815900928 -8.25982068413 598.978526651 2.4815900928 -8.26482068413 594.966185086 2.4815900928 -8.26982068413 588.838313887 2.4815900928 -8.27482068413 579.324360611 2.4815900928 -8.27982068413 560.420162514 2.4815900928 -8.28482068413 540.397701448 2.4815900928 -8.28982068413 524.084764987 2.4815900928 -8.29482068413 506.172935744 2.4815900928 -8.29982068413 489.761658164 2.4815900928 -8.30482068413 478.165806597 2.4815900928 -8.30982068413 474.384262309 2.4815900928 -8.31482068413 475.072739224 2.4815900928 -8.31982068413 478.916085939 2.4815900928 -8.32482068413 485.821528463 2.4815900928 -8.32982068413 498.014415842 2.4815900928 -8.33482068413 512.93280466 2.4815900928 -8.33982068413 524.225608263 2.4815900928 -8.34482068413 538.569060517 2.4815900928 -8.34982068413 554.279563331 2.4815900928 -8.35482068413 567.010627913 2.4815900928 -8.35982068413 576.297741641 2.4815900928 -8.36482068413 588.682064123 2.4815900928 -8.36982068413 603.650111008 2.4815900928 -8.37482068413 618.808837115 2.4815900928 -8.37982068413 633.992995135 2.4815900928 -8.38482068413 664.394091991 2.4815900928 -8.38982068413 700.299342234 2.4815900928 -8.39482068413 722.723753119 2.4815900928 -8.39982068413 758.096293789 2.4815900928 -8.40482068413 794.160371109 2.4815900928 -8.40982068413 829.638852494 2.4815900928 -8.41482068413 856.851264617 2.4815900928 -8.41982068413 883.143331382 2.4815900928 -8.42482068413 906.287479348 2.4815900928 -8.42982068413 920.157734122 2.4815900928 -8.43482068413 927.624970386 2.4815900928 -8.43982068413 933.869660824 2.4815900928 -8.44482068413 925.39019615 2.4815900928 -8.44982068413 930.452703138 2.4815900928 -8.45482068413 922.816290138 2.4815900928 -8.45982068413 923.221990318 2.4815900928 -8.46482068413 919.11563099 2.4815900928 -8.46982068413 916.712360222 2.4815900928 -8.47482068413 899.509451489 2.4815900928 -8.47982068413 877.190475535 2.4815900928 -8.48482068413 844.428685242 -0.777339947265 -8.48982068413 843.829829226 -0.918919462293 -8.49482068413 809.457300872 -1.09023136704 -8.49982068413 773.986634659 -1.09023136704 -8.50482068413 738.135694138 -1.09023136704 -8.50982068413 707.539762393 -1.09023136704 -8.51482068413 641.25031974 -1.09023136704 -8.51982068413 611.9323203 -1.09023136704 -8.52482068413 575.92298925 -1.09023136704 -8.52982068413 518.432920766 -1.09023136704 -8.53482068413 459.91032272 -1.09023136704 -8.53982068413 413.534924415 -1.09023136704 -8.54482068413 328.735019161 -1.09023136704 -8.54982068413 319.755409665 -1.09023136704 -8.55482068413 312.36396112 -1.09023136704 -8.55982068413 259.968528265 -1.09023136704 -8.56482068413 230.212497667 -1.09023136704 -8.56982068413 192.347083827 -1.09023136704 -8.57482068413 173.36269392 -1.09023136704 -8.57982068413 172.210436833 -1.09023136704 -8.58482068413 153.501171164 -1.09023136704 -8.58982068413 152.942601621 -1.09023136704 -8.59482068413 490.554707223 -1.09023136704 -8.59982068413 385.60332081 -1.09023136704 -8.60482068413 253.073434964 -1.09023136704 -8.60982068413 279.442100497 -1.09023136704 -8.61482068413 297.081225035 -1.09023136704 -8.61982068413 226.643444855 -1.09023136704 -8.62482068413 199.136260099 -1.09023136704 -8.62982068413 338.350283407 -1.09023136704 -8.63482068413 339.022746929 -1.09023136704 -8.63982068413 391.590888118 -1.09023136704 -8.64482068413 414.682888192 -1.09023136704 -8.64982068413 443.478991686 -1.09023136704 -8.65482068413 456.404011601 -1.09023136704 -8.65982068413 452.303691981 -1.09023136704 -8.66482068413 433.324722775 -1.09023136704 -8.66982068413 453.379202577 -1.09023136704 -8.67482068413 444.403261522 -1.09023136704 -8.67982068413 415.941437653 -1.09023136704 -8.68482068413 401.100394428 -1.09023136704 -8.68982068413 381.298683138 -1.09023136704 -8.69482068413 369.725384509 -1.09023136704 -8.69982068413 367.917029836 -1.09023136704 -8.70482068413 371.303646877 -1.09023136704 -8.70982068413 380.545480098 -1.09023136704 -8.71482068413 388.556880217 -1.09023136704 -8.71982068413 408.506081358 -1.09023136704 -8.72482068413 418.310907455 -1.09023136704 -8.72982068413 428.852904122 -1.09023136704 -8.73482068413 439.01962849 -1.09023136704 -8.73982068413 444.903357791 -1.09023136704 -8.74482068413 455.074521265 -1.09023136704 -8.74982068413 450.802990121 -1.09023136704 -8.75482068413 447.218317237 -1.09023136704 -8.75982068413 442.337478238 -1.09023136704 -8.76482068413 433.219380583 -1.09023136704 -8.76982068413 426.011842805 -1.09023136704 -8.77482068413 422.436413282 -1.09023136704 -8.77982068413 406.794887031 -1.09023136704 -8.78482068413 398.689532389 -1.09023136704 -8.78982068413 406.822714905 -1.09023136704 -8.79482068413 394.983950304 -1.09023136704 -8.79982068413 367.190071791 -1.09023136704 -8.80482068413 361.948262643 -1.09023136704 -8.80982068413 346.735916909 -1.09023136704 -8.81482068413 339.769012045 -1.09023136704 -8.81982068413 326.839421254 -1.09023136704 -8.82482068413 320.514381942 -1.09023136704 -8.82982068413 321.226045725 -1.09023136704 -8.83482068413 314.658072068 -1.09023136704 -8.83982068413 309.681051527 -1.09023136704 -8.84482068413 304.099653725 -1.09023136704 -8.84982068413 303.857088529 -1.09023136704 -8.85482068413 306.220577293 -1.09023136704 -8.85982068413 300.096000662 -1.09023136704 -8.86482068413 298.450284379 -1.09023136704 -8.86982068413 297.955468233 -1.09023136704 -8.87482068413 292.785202387 -1.09023136704 -8.87982068413 286.454993532 -1.09023136704 -8.88482068413 283.510117148 -1.09023136704 -8.88982068413 283.997350746 -1.09023136704 -8.89482068413 277.35785323 -1.09023136704 -8.89982068413 271.113407954 -1.09023136704 -8.90482068413 266.499733124 -1.09023136704 -8.90982068413 265.163771095 -1.09023136704 -8.91482068413 260.108785648 -1.09023136704 -8.91982068413 248.820841311 -1.09023136704 -8.92482068413 244.75137721 -1.09023136704 -8.92982068413 244.70230318 -1.09023136704 -8.93482068413 232.464342121 -1.09023136704 -8.93982068413 222.982581771 -1.09023136704 -8.94482068413 211.001910828 -1.09023136704 -8.94982068413 203.878997006 -1.09023136704 -8.95482068413 192.041997531 -1.09023136704 -8.95982068413 179.268272432 -1.09023136704 -8.96482068413 167.077118029 -1.09023136704 -8.96982068413 159.067042523 -1.09023136704 -8.97482068413 142.620760281 -1.09023136704 -8.97982068413 128.783107249 -1.09023136704 -8.98482068413 117.074095891 -1.09023136704 -8.98982068413 105.319951127 -1.09023136704 -8.99482068413 95.554249334 -1.09023136704 -8.99982068413 83.545146582 -1.09023136704 -9.00482068413 64.2595430578 -1.09023136704 -9.00982068413 43.9599002164 -1.09023136704 -9.01482068413 27.5647257131 -1.09023136704 -9.01982068413 18.6408696338 -1.09023136704 -9.02482068413 -14.0068688174 -1.09023136704 -9.02982068413 -10.3577275246 -1.09023136704 -9.03482068413 -37.1106822721 -1.09023136704 -9.03982068413 -13.5177725272 -1.09023136704 -9.04482068413 -24.7951715114 -1.09023136704 -9.04982068413 -34.786144465 -1.09023136704 -9.05482068413 -43.9438510117 -1.09023136704 -9.05982068413 -50.4932266405 -1.09023136704 -9.06482068413 -50.4932266405 -1.09023136704 -9.06982068413 -50.4932266405 -1.09023136704 -9.07482068413 -50.4932266405 -1.09023136704 -9.07982068413 -50.4932266405 -1.09023136704 -9.08482068413 -50.4932266405 -1.09023136704 -9.08982068413 -50.4932266405 -1.09023136704 -9.09482068413 -50.4932266405 -1.09023136704 -9.09982068413 -50.4932266405 -1.09023136704 -9.10482068413 -50.4932266405 -1.09023136704 -9.10982068413 -50.4932266405 -1.09023136704 -9.11482068413 -50.4932266405 -1.09023136704 -9.11982068413 -50.4932266405 -1.09023136704 -9.12482068413 -50.4932266405 -1.09023136704 -9.12982068413 -50.4932266405 -1.09023136704 -9.13482068413 -50.4932266405 -1.09023136704 -9.13982068413 -50.4932266405 -1.09023136704 -9.14482068413 -50.4932266405 -1.09023136704 -9.14982068413 -50.4932266405 -1.09023136704 -9.15482068413 -50.4932266405 -1.09023136704 -9.15982068413 -50.4932266405 -1.09023136704 -9.16482068413 -50.4932266405 -1.09023136704 -9.16982068413 -50.4932266405 -1.09023136704 -9.17482068413 -50.4932266405 -1.09023136704 -9.17982068413 -50.4932266405 -1.09023136704 -9.18482068413 -50.4932266405 -1.09023136704 -9.18982068413 -50.4932266405 -1.09023136704 -9.19482068413 -50.4932266405 -1.09023136704 -9.19982068413 -50.4932266405 -1.09023136704 -9.20482068413 -50.4932266405 -1.09023136704 -9.20982068413 -50.4932266405 -1.09023136704 -9.21482068413 -50.4932266405 -1.09023136704 -9.21982068413 -50.4932266405 -1.09023136704 -9.22482068413 -50.4932266405 -1.09023136704 -9.22982068413 -50.4932266405 -1.09023136704 -9.23482068413 -50.4932266405 -1.09023136704 -9.23982068413 -50.4932266405 -1.09023136704 -9.24482068413 -50.4932266405 -1.09023136704 -9.24982068413 -50.4932266405 -1.09023136704 -9.25482068413 -50.4932266405 -1.09023136704 -9.25982068413 -50.4932266405 -1.09023136704 -9.26482068413 -50.4932266405 -1.09023136704 -9.26982068413 -50.4932266405 -1.09023136704 -9.27482068413 -50.4932266405 -1.09023136704 -9.27982068413 -50.4932266405 -1.09023136704 -9.28482068413 -50.4932266405 -1.09023136704 -9.28982068413 -50.4932266405 -1.09023136704 -9.29482068413 -50.4932266405 -1.09023136704 -9.29982068413 -50.4932266405 -1.09023136704 -9.30482068413 -50.4932266405 -1.09023136704 -9.30982068413 -50.4932266405 -1.09023136704 -9.31482068413 -50.4932266405 -1.09023136704 -9.31982068413 -50.4932266405 -1.09023136704 -9.32482068413 -50.4932266405 -1.09023136704 -9.32982068413 -50.4932266405 -1.09023136704 -9.33482068413 -50.4932266405 -1.09023136704 -9.33982068413 -50.4932266405 -1.09023136704 -9.34482068413 -50.4932266405 -1.09023136704 -9.34982068413 -50.4932266405 -1.09023136704 -9.35482068413 -50.4932266405 -1.09023136704 -9.35982068413 -50.4932266405 -1.09023136704 -9.36482068413 -50.4932266405 -1.09023136704 -9.36982068413 -50.4932266405 -1.09023136704 -9.37482068413 -50.4932266405 -1.09023136704 -9.37982068413 -50.4932266405 -1.09023136704 -9.38482068413 -50.4932266405 -1.09023136704 -9.38982068413 -50.4932266405 -1.09023136704 -9.39482068413 -50.4932266405 -1.09023136704 -9.39982068413 -50.4932266405 -1.09023136704 -9.40482068413 -50.4932266405 -1.09023136704 -9.40982068413 -50.4932266405 -1.09023136704 -9.41482068413 -50.4932266405 -1.09023136704 -9.41982068413 -50.4932266405 -1.09023136704 -9.42482068413 -50.4932266405 -1.09023136704 -9.42982068413 -50.4932266405 -1.09023136704 -9.43482068413 -50.4932266405 -1.09023136704 -9.43982068413 -50.4932266405 -1.09023136704 -9.44482068413 -50.4932266405 -1.09023136704 -9.44982068413 -50.4932266405 -1.09023136704 -9.45482068413 -50.4932266405 -1.09023136704 -9.45982068413 -50.4932266405 -1.09023136704 -9.46482068413 -50.4932266405 -1.09023136704 -9.46982068413 -50.4932266405 -1.09023136704 -9.47482068413 -50.4932266405 -1.09023136704 -9.47982068413 -50.4932266405 -1.09023136704 -9.48482068413 -50.4932266405 -1.09023136704 -9.48982068413 -50.4932266405 -1.09023136704 -9.49482068413 -50.4932266405 -1.09023136704 -9.49982068413 -50.4932266405 -1.09023136704 -9.50482068413 -50.4932266405 -1.09023136704 -9.50982068413 -50.4932266405 -1.09023136704 -9.51482068413 -50.4932266405 -1.09023136704 -9.51982068413 -50.4932266405 -1.09023136704 -9.52482068413 -50.4932266405 -1.09023136704 -9.52982068413 -50.4932266405 -1.09023136704 -9.53482068413 -50.4932266405 -1.09023136704 -9.53982068413 -50.4932266405 -1.09023136704 -9.54482068413 -50.4932266405 -1.09023136704 -9.54982068413 -50.4932266405 -1.09023136704 -9.55482068413 -50.4932266405 -1.09023136704 -9.55982068413 -50.4932266405 -1.09023136704 -9.56482068413 -50.4932266405 -1.09023136704 -9.56982068413 -50.4932266405 -1.09023136704 -9.57482068413 -50.4932266405 -1.09023136704 -9.57982068413 -50.4932266405 -1.09023136704 -9.58482068413 -50.4932266405 -1.09023136704 -9.58982068413 -50.4932266405 -1.09023136704 -9.59482068413 -50.4932266405 -1.09023136704 -9.59982068413 -50.4932266405 -1.09023136704 -9.60482068413 -50.4932266405 -1.09023136704 -9.60982068413 -50.4932266405 -1.09023136704 -9.61482068413 -50.4932266405 -1.09023136704 -9.61982068413 -50.4932266405 -1.09023136704 -9.62482068413 -50.4932266405 -1.09023136704 -9.62982068413 -50.4932266405 -1.09023136704 -9.63482068413 -50.4932266405 -1.09023136704 -9.63982068413 -50.4932266405 -1.09023136704 -9.64482068413 -50.4932266405 -1.09023136704 -9.64982068413 -50.4932266405 -1.09023136704 -9.65482068413 -50.4932266405 -1.09023136704 -9.65982068413 -50.4932266405 -1.09023136704 -9.66482068413 -50.4932266405 -1.09023136704 -9.66982068413 -50.4932266405 -1.09023136704 -9.67482068413 -50.4932266405 -1.09023136704 -9.67982068413 -50.4932266405 -1.09023136704 -9.68482068413 -50.4932266405 -1.09023136704 -9.68982068413 -50.4932266405 -1.09023136704 -9.69482068413 -50.4932266405 -1.09023136704 -9.69982068413 -50.4932266405 -1.09023136704 -9.70482068413 -50.4932266405 -1.09023136704 -9.70982068413 -50.4932266405 -1.09023136704 -9.71482068413 -50.4932266405 -1.09023136704 -9.71982068413 -50.4932266405 -1.09023136704 -9.72482068413 -50.4932266405 -1.09023136704 -9.72982068413 -50.4932266405 -1.09023136704 -9.73482068413 -50.4932266405 -1.09023136704 -9.73982068413 -50.4932266405 -1.09023136704 -9.74482068413 -50.4932266405 -1.09023136704 -9.74982068413 -50.4932266405 -1.09023136704 -9.75482068413 -50.4932266405 -1.09023136704 -9.75982068413 -50.4932266405 -1.09023136704 -9.76482068413 -50.4932266405 -1.09023136704 -9.76982068413 -50.4932266405 -1.09023136704 -9.77482068413 -50.4932266405 -1.09023136704 -9.77982068413 -50.4932266405 -1.09023136704 -9.78482068413 -50.4932266405 -1.09023136704 -9.78982068413 -50.4932266405 -1.09023136704 -9.79482068413 -50.4932266405 -1.09023136704 -9.79982068413 -50.4932266405 -1.09023136704 -9.80482068413 -50.4932266405 -1.09023136704 -9.80982068413 -50.4932266405 -1.09023136704 -9.81482068413 -50.4932266405 -1.09023136704 -9.81982068413 -50.4932266405 -1.09023136704 -9.82482068413 -50.4932266405 -1.09023136704 -9.82982068413 -50.4932266405 -1.09023136704 -9.83482068413 -50.4932266405 -1.09023136704 -9.83982068413 -50.4932266405 -1.09023136704 -9.84482068413 -50.4932266405 -1.09023136704 -9.84982068413 -50.4932266405 -1.09023136704 -9.85482068413 -50.4932266405 -1.09023136704 -9.85982068413 -50.4932266405 -1.09023136704 -9.86482068413 -50.4932266405 -1.09023136704 -9.86982068413 -50.4932266405 -1.09023136704 -9.87482068413 -50.4932266405 -1.09023136704 -9.87982068413 -50.4932266405 -1.09023136704 -9.88482068413 -50.4932266405 -1.09023136704 -9.88982068413 -50.4932266405 -1.09023136704 -9.89482068413 -50.4932266405 -1.09023136704 -9.89982068413 -50.4932266405 -1.09023136704 -9.90482068413 -50.4932266405 -1.09023136704 -9.90982068413 -50.4932266405 -1.09023136704 -9.91482068413 -50.4932266405 -1.09023136704 -9.91982068413 -50.4932266405 -1.09023136704 -9.92482068413 -50.4932266405 -1.09023136704 -9.92982068413 -50.4932266405 -1.09023136704 -9.93482068413 -50.4932266405 -1.09023136704 -9.93982068413 -50.4932266405 -1.09023136704 -9.94482068413 -50.4932266405 -1.09023136704 -9.94982068413 -50.4932266405 -1.09023136704 -9.95482068413 -50.4932266405 -1.09023136704 -9.95982068413 -50.4932266405 -1.09023136704 -9.96482068413 -50.4932266405 -1.09023136704 -9.96982068413 -50.4932266405 -1.09023136704 -9.97482068413 -50.4932266405 -1.09023136704 -9.97982068413 -50.4932266405 -1.09023136704 -9.98482068413 -50.4932266405 -1.09023136704 -9.98982068413 -50.4932266405 -1.09023136704 -9.99482068413 -50.4932266405 -1.09023136704 -9.99982068413 -50.4932266405 -1.09023136704 -10.0048206841 -50.4932266405 -1.09023136704 -10.0098206841 -50.4932266405 -1.09023136704 -10.0148206841 291.907740917 -1.09023136704 -10.0198206841 381.698543129 -1.09023136704 -10.0248206841 481.658449896 -1.09023136704 -10.0298206841 1173.98961508 -1.09023136704 -10.0348206841 1515.3604985 -1.09023136704 -10.0398206841 1993.62466976 -1.09023136704 -10.0448206841 2132.2409352 -1.09023136704 -10.0498206841 1924.8375966 -1.09023136704 -10.0548206841 1686.82791388 -1.09023136704 -10.0598206841 1067.3712092 -1.09023136704 -10.0648206841 860.194197517 -1.09023136704 -10.0698206841 609.630396583 -1.09023136704 -10.0748206841 468.010216718 -1.09023136704 -10.0798206841 396.978664775 -1.09023136704 -10.0848206841 378.452876289 -1.09023136704 -10.0898206841 378.264810676 -1.09023136704 -10.0948206841 393.887638567 -1.09023136704 -10.0998206841 426.379149591 -1.09023136704 -10.1048206841 465.13804213 -1.09023136704 -10.1098206841 483.403426585 -1.09023136704 -10.1148206841 514.178223135 -1.09023136704 -10.1198206841 523.052006284 -1.09023136704 -10.1248206841 529.563823382 -1.09023136704 -10.1298206841 540.60182448 3.92143304247 -10.1348206841 549.421345577 3.912887874 -10.1398206841 558.513535321 3.912887874 -10.1448206841 575.434290135 3.912887874 -10.1498206841 587.819082005 3.912887874 -10.1548206841 601.919219449 3.912887874 -10.1598206841 613.069270051 3.912887874 -10.1648206841 625.296343483 3.912887874 -10.1698206841 631.813789971 3.912887874 -10.1748206841 633.028703883 3.912887874 -10.1798206841 634.387873479 3.912887874 -10.1848206841 633.800774301 3.912887874 -10.1898206841 631.561978608 3.912887874 -10.1948206841 626.152263365 3.912887874 -10.1998206841 617.441160542 3.912887874 -10.2048206841 609.79456981 3.912887874 -10.2098206841 598.835103005 3.912887874 -10.2148206841 591.197450682 3.912887874 -10.2198206841 586.573784874 3.912887874 -10.2248206841 582.399464767 3.912887874 -10.2298206841 580.563837228 3.912887874 -10.2348206841 580.904597445 3.912887874 -10.2398206841 584.828458245 3.912887874 -10.2448206841 592.016978348 3.912887874 -10.2498206841 601.611750363 3.912887874 -10.2548206841 613.455706665 3.912887874 -10.2598206841 629.381737174 3.912887874 -10.2648206841 648.1160804 3.912887874 -10.2698206841 669.508455254 3.912887874 -10.2748206841 692.665798672 3.912887874 -10.2798206841 713.954147291 3.912887874 -10.2848206841 735.604302872 3.912887874 -10.2898206841 756.12741523 3.912887874 -10.2948206841 774.466450074 3.912887874 -10.2998206841 799.222357682 3.912887874 -10.3048206841 821.96951822 3.912887874 -10.3098206841 839.738471898 3.912887874 -10.3148206841 859.639760556 3.912887874 -10.3198206841 870.926709021 3.912887874 -10.3248206841 885.382894714 3.912887874 -10.3298206841 891.852300886 3.912887874 -10.3348206841 896.968415501 3.912887874 -10.3398206841 899.084929638 3.912887874 -10.3448206841 895.934905065 3.912887874 -10.3498206841 892.172908668 3.912887874 -10.3548206841 879.789377555 3.912887874 -10.3598206841 864.858698325 3.912887874 -10.3648206841 846.332317092 3.912887874 -10.3698206841 820.274173971 3.912887874 -10.3748206841 792.998801189 3.912887874 -10.3798206841 760.789183213 3.912887874 -10.3848206841 748.883180893 3.912887874 -10.3898206841 744.429042667 3.912887874 -10.3948206841 712.726310687 3.912887874 -10.3998206841 681.616194729 3.912887874 -10.4048206841 655.497188472 3.912887874 -10.4098206841 632.430984753 3.912887874 -10.4148206841 637.290676172 3.912887874 -10.4198206841 593.902397302 3.912887874 -10.4248206841 568.200075833 3.912887874 -10.4298206841 535.662138143 3.912887874 -10.4348206841 498.45510711 3.912887874 -10.4398206841 468.251739365 3.912887874 -10.4448206841 405.62616366 3.912887874 -10.4498206841 376.958492435 3.912887874 -10.4548206841 362.110577804 3.912887874 -10.4598206841 348.723943146 3.912887874 -10.4648206841 339.91771928 3.912887874 -10.4698206841 350.659038648 3.912887874 -10.4748206841 342.776664414 3.912887874 -10.4798206841 329.205622503 3.912887874 -10.4848206841 343.141761615 3.912887874 -10.4898206841 336.397874496 3.912887874 -10.4948206841 334.605988163 3.912887874 -10.4998206841 340.182842793 3.912887874 -10.5048206841 355.614783338 3.912887874 -10.5098206841 361.802973078 3.912887874 -10.5148206841 370.022508634 3.912887874 -10.5198206841 376.332438767 3.912887874 -10.5248206841 390.612782705 3.912887874 -10.5298206841 407.453521337 3.912887874 -10.5348206841 419.53116547 3.912887874 -10.5398206841 554.995540642 3.912887874 -10.5448206841 488.767313893 3.912887874 -10.5498206841 451.460079279 3.912887874 -10.5548206841 444.97560302 3.912887874 -10.5598206841 429.259040786 3.912887874 -10.5648206841 416.607478308 3.912887874 -10.5698206841 411.468623789 3.912887874 -10.5748206841 407.759927941 3.912887874 -10.5798206841 401.546194317 3.912887874 -10.5848206841 402.050669566 3.912887874 -10.5898206841 388.976855932 3.912887874 -10.5948206841 381.172802385 3.912887874 -10.5998206841 378.908023354 3.912887874 -10.6048206841 375.183475831 3.912887874 -10.6098206841 375.293248872 3.912887874 -10.6148206841 374.356423619 3.912887874 -10.6198206841 375.671125031 3.912887874 -10.6248206841 376.154879811 3.912887874 -10.6298206841 381.422598774 3.912887874 -10.6348206841 383.666766598 3.912887874 -10.6398206841 388.38086066 3.912887874 -10.6448206841 394.042050138 3.912887874 -10.6498206841 393.965318318 3.912887874 -10.6548206841 393.705288325 3.912887874 -10.6598206841 395.788150987 3.912887874 -10.6648206841 392.270087573 3.912887874 -10.6698206841 393.863528612 3.912887874 -10.6748206841 387.646357156 3.912887874 -10.6798206841 383.375925134 3.912887874 -10.6848206841 376.015290411 3.912887874 -10.6898206841 358.745150255 3.912887874 -10.6948206841 351.917456734 3.912887874 -10.6998206841 343.06979548 3.912887874 -10.7048206841 340.022466878 3.912887874 -10.7098206841 333.064584776 3.912887874 -10.7148206841 324.558475237 3.912887874 -10.7198206841 319.144380553 3.912887874 -10.7248206841 308.238564525 3.912887874 -10.7298206841 304.035206954 3.912887874 -10.7348206841 299.957880946 3.912887874 -10.7398206841 297.389176794 3.912887874 -10.7448206841 292.824371473 3.912887874 -10.7498206841 287.219732694 3.912887874 -10.7548206841 289.188245224 3.912887874 -10.7598206841 287.524477797 3.912887874 -10.7648206841 284.116199306 3.912887874 -10.7698206841 273.520062842 3.912887874 -10.7748206841 269.834818971 3.912887874 -10.7798206841 263.492077401 3.912887874 -10.7848206841 261.763822697 3.912887874 -10.7898206841 259.812974778 3.912887874 -10.7948206841 247.271513611 3.912887874 -10.7998206841 213.126899061 3.912887874 -10.8048206841 210.591312401 3.912887874 -10.8098206841 230.008151326 3.912887874 -10.8148206841 216.526585552 3.912887874 -10.8198206841 206.819993437 3.912887874 -10.8248206841 198.715112026 3.912887874 -10.8298206841 192.798585043 3.912887874 -10.8348206841 184.642162203 3.912887874 -10.8398206841 178.104436328 3.912887874 -10.8448206841 173.585835294 3.912887874 -10.8498206841 169.586057279 3.912887874 -10.8548206841 164.667510401 3.912887874 -10.8598206841 157.02598215 3.912887874 -10.8648206841 150.274024765 3.912887874 -10.8698206841 141.242963657 3.912887874 -10.8748206841 129.912120863 3.912887874 -10.8798206841 118.942839563 3.912887874 -10.8848206841 103.892162512 3.912887874 -10.8898206841 91.2709457563 3.912887874 -10.8948206841 80.8509647069 3.912887874 -10.8998206841 73.483346982 3.912887874 -10.9048206841 60.0590122727 3.912887874 -10.9098206841 47.5323218118 3.912887874 -10.9148206841 35.0771648706 3.912887874 -10.9198206841 23.3992787548 3.912887874 -10.9248206841 22.8319785602 3.912887874 -10.9298206841 9.72924222106 3.912887874 -10.9348206841 -19.82463382 3.912887874 -10.9398206841 -11.3748458111 3.912887874 -10.9448206841 -11.3748458111 3.912887874 -10.9498206841 -48.3817312855 3.912887874 -10.9548206841 -70.6368493735 3.912887874 -10.9598206841 -80.8969655484 3.912887874 -10.9648206841 -85.8283633063 3.912887874 -10.9698206841 -73.6853466366 3.912887874 -10.9748206841 -71.5289503879 3.912887874 -10.9798206841 -73.2543524301 3.912887874 -10.9848206841 -48.6569260734 3.912887874 -10.9898206841 -70.1115567287 3.912887874 -10.9948206841 -25.5246647678 3.912887874 -10.9998206841 -20.9876052105 3.912887874 -11.0048206841 -20.9876052105 3.912887874 -11.0098206841 -20.9876052105 3.912887874 -11.0148206841 -20.9876052105 3.912887874 -11.0198206841 -20.9876052105 3.912887874 -11.0248206841 -20.9876052105 3.912887874 -11.0298206841 -20.9876052105 3.912887874 -11.0348206841 -20.9876052105 3.912887874 -11.0398206841 -20.9876052105 3.912887874 -11.0448206841 -20.9876052105 3.912887874 -11.0498206841 -20.9876052105 3.912887874 -11.0548206841 -20.9876052105 3.912887874 -11.0598206841 -20.9876052105 3.912887874 -11.0648206841 -20.9876052105 3.912887874 -11.0698206841 -20.9876052105 3.912887874 -11.0748206841 -20.9876052105 3.912887874 -11.0798206841 -20.9876052105 3.912887874 -11.0848206841 -20.9876052105 3.912887874 -11.0898206841 -20.9876052105 3.912887874 -11.0948206841 -20.9876052105 3.912887874 -11.0998206841 -20.9876052105 3.912887874 -11.1048206841 -20.9876052105 3.912887874 -11.1098206841 -20.9876052105 3.912887874 -11.1148206841 -20.9876052105 3.912887874 -11.1198206841 -20.9876052105 3.912887874 -11.1248206841 -20.9876052105 3.912887874 -11.1298206841 -20.9876052105 3.912887874 -11.1348206841 -20.9876052105 3.912887874 -11.1398206841 -20.9876052105 3.912887874 -11.1448206841 -20.9876052105 3.912887874 -11.1498206841 -20.9876052105 3.912887874 -11.1548206841 -20.9876052105 3.912887874 -11.1598206841 -20.9876052105 3.912887874 -11.1648206841 -20.9876052105 3.912887874 -11.1698206841 -20.9876052105 3.912887874 -11.1748206841 -20.9876052105 3.912887874 -11.1798206841 -20.9876052105 3.912887874 -11.1848206841 -20.9876052105 3.912887874 -11.1898206841 -20.9876052105 3.912887874 -11.1948206841 -20.9876052105 3.912887874 -11.1998206841 -20.9876052105 3.912887874 -11.2048206841 -20.9876052105 3.912887874 -11.2098206841 -20.9876052105 3.912887874 -11.2148206841 -20.9876052105 3.912887874 -11.2198206841 -20.9876052105 3.912887874 -11.2248206841 -20.9876052105 3.912887874 -11.2298206841 -20.9876052105 3.912887874 -11.2348206841 -20.9876052105 3.912887874 -11.2398206841 -20.9876052105 3.912887874 -11.2448206841 -20.9876052105 3.912887874 -11.2498206841 -20.9876052105 3.912887874 -11.2548206841 -20.9876052105 3.912887874 -11.2598206841 -20.9876052105 3.912887874 -11.2648206841 -20.9876052105 3.912887874 -11.2698206841 -20.9876052105 3.912887874 -11.2748206841 -20.9876052105 3.912887874 -11.2798206841 -20.9876052105 3.912887874 -11.2848206841 -20.9876052105 3.912887874 -11.2898206841 -20.9876052105 3.912887874 -11.2948206841 -20.9876052105 3.912887874 -11.2998206841 -20.9876052105 3.912887874 -11.3048206841 -20.9876052105 3.912887874 -11.3098206841 -20.9876052105 3.912887874 -11.3148206841 -20.9876052105 3.912887874 -11.3198206841 -20.9876052105 3.912887874 -11.3248206841 -20.9876052105 3.912887874 -11.3298206841 -20.9876052105 3.912887874 -11.3348206841 -20.9876052105 3.912887874 -11.3398206841 -20.9876052105 3.912887874 -11.3448206841 -20.9876052105 3.912887874 -11.3498206841 -20.9876052105 3.912887874 -11.3548206841 -20.9876052105 3.912887874 -11.3598206841 -20.9876052105 3.912887874 -11.3648206841 -20.9876052105 3.912887874 -11.3698206841 -20.9876052105 3.912887874 -11.3748206841 -20.9876052105 3.912887874 -11.3798206841 -20.9876052105 3.912887874 -11.3848206841 -20.9876052105 3.912887874 -11.3898206841 -20.9876052105 3.912887874 -11.3948206841 -20.9876052105 3.912887874 -11.3998206841 -20.9876052105 3.912887874 -11.4048206841 -20.9876052105 3.912887874 -11.4098206841 -20.9876052105 3.912887874 -11.4148206841 -20.9876052105 3.912887874 -11.4198206841 -20.9876052105 3.912887874 -11.4248206841 -20.9876052105 3.912887874 -11.4298206841 -20.9876052105 3.912887874 -11.4348206841 -20.9876052105 3.912887874 -11.4398206841 -20.9876052105 3.912887874 -11.4448206841 -20.9876052105 3.912887874 -11.4498206841 -20.9876052105 3.912887874 -11.4548206841 -20.9876052105 3.912887874 -11.4598206841 -20.9876052105 3.912887874 -11.4648206841 -20.9876052105 3.912887874 -11.4698206841 -20.9876052105 3.912887874 -11.4748206841 -20.9876052105 3.912887874 -11.4798206841 -20.9876052105 3.912887874 -11.4848206841 -20.9876052105 3.912887874 -11.4898206841 -20.9876052105 3.912887874 -11.4948206841 -20.9876052105 3.912887874 -11.4998206841 -20.9876052105 3.912887874 -11.5048206841 -20.9876052105 3.912887874 -11.5098206841 -20.9876052105 3.912887874 -11.5148206841 -20.9876052105 3.912887874 -11.5198206841 -20.9876052105 3.912887874 -11.5248206841 -20.9876052105 3.912887874 -11.5298206841 -20.9876052105 3.912887874 -11.5348206841 -20.9876052105 3.912887874 -11.5398206841 -20.9876052105 3.912887874 -11.5448206841 -20.9876052105 3.912887874 -11.5498206841 -20.9876052105 3.912887874 -11.5548206841 -20.9876052105 3.912887874 -11.5598206841 -20.9876052105 3.912887874 -11.5648206841 -20.9876052105 3.912887874 -11.5698206841 -20.9876052105 3.912887874 -11.5748206841 -20.9876052105 3.912887874 -11.5798206841 -20.9876052105 3.912887874 -11.5848206841 -20.9876052105 3.912887874 -11.5898206841 -20.9876052105 3.912887874 -11.5948206841 -20.9876052105 3.912887874 -11.5998206841 -20.9876052105 3.912887874 -11.6048206841 -20.9876052105 3.912887874 -11.6098206841 -20.9876052105 3.912887874 -11.6148206841 -20.9876052105 3.912887874 -11.6198206841 -20.9876052105 3.912887874 -11.6248206841 -20.9876052105 3.912887874 -11.6298206841 -20.9876052105 3.912887874 -11.6348206841 -20.9876052105 3.912887874 -11.6398206841 -20.9876052105 3.912887874 -11.6448206841 -20.9876052105 3.912887874 -11.6498206841 -20.9876052105 3.912887874 -11.6548206841 -20.9876052105 3.912887874 -11.6598206841 -20.9876052105 3.912887874 -11.6648206841 -20.9876052105 3.912887874 -11.6698206841 -20.9876052105 3.912887874 -11.6748206841 -20.9876052105 3.912887874 -11.6798206841 -20.9876052105 3.912887874 -11.6848206841 -20.9876052105 3.912887874 -11.6898206841 -20.9876052105 3.912887874 -11.6948206841 -20.9876052105 3.912887874 -11.6998206841 -20.9876052105 3.912887874 -11.7048206841 -20.9876052105 3.912887874 -11.7098206841 -20.9876052105 3.912887874 -11.7148206841 -20.9876052105 3.912887874 -11.7198206841 -20.9876052105 3.912887874 -11.7248206841 -20.9876052105 3.912887874 -11.7298206841 -20.9876052105 3.912887874 -11.7348206841 -20.9876052105 3.912887874 -11.7398206841 -20.9876052105 3.912887874 -11.7448206841 -20.9876052105 3.912887874 -11.7498206841 -20.9876052105 3.912887874 -11.7548206841 -20.9876052105 3.912887874 -11.7598206841 -20.9876052105 3.912887874 -11.7648206841 -20.9876052105 3.912887874 -11.7698206841 -20.9876052105 3.912887874 -11.7748206841 -20.9876052105 3.912887874 -11.7798206841 -20.9876052105 3.912887874 -11.7848206841 -20.9876052105 3.912887874 -11.7898206841 -20.9876052105 3.912887874 -11.7948206841 -20.9876052105 3.912887874 -11.7998206841 -20.9876052105 3.912887874 -11.8048206841 -20.9876052105 3.912887874 -11.8098206841 -20.9876052105 3.912887874 -11.8148206841 -20.9876052105 3.912887874 -11.8198206841 -20.9876052105 3.912887874 -11.8248206841 -20.9876052105 3.912887874 -11.8298206841 -20.9876052105 3.912887874 -11.8348206841 -20.9876052105 3.912887874 -11.8398206841 -20.9876052105 3.912887874 -11.8448206841 -20.9876052105 3.912887874 -11.8498206841 -20.9876052105 3.912887874 -11.8548206841 -20.9876052105 3.912887874 -11.8598206841 -20.9876052105 3.912887874 -11.8648206841 -20.9876052105 3.912887874 -11.8698206841 -20.9876052105 3.912887874 -11.8748206841 -20.9876052105 3.912887874 -11.8798206841 -20.9876052105 3.912887874 -11.8848206841 -20.9876052105 3.912887874 -11.8898206841 -20.9876052105 3.912887874 -11.8948206841 -20.9876052105 3.912887874 -11.8998206841 -20.9876052105 3.912887874 -11.9048206841 -20.9876052105 3.912887874 -11.9098206841 -20.9876052105 3.912887874 -11.9148206841 -20.9876052105 3.912887874 -11.9198206841 464.737889177 3.912887874 -11.9248206841 1146.20942818 3.912887874 -11.9298206841 1198.99469728 3.912887874 -11.9348206841 1350.76603559 3.912887874 -11.9398206841 1447.54526823 3.912887874 -11.9448206841 1496.12880707 3.912887874 -11.9498206841 1572.58068141 3.912887874 -11.9548206841 1243.44768804 3.912887874 -11.9598206841 969.736005916 3.912887874 -11.9648206841 811.12510228 3.912887874 -11.9698206841 624.129905476 3.912887874 -11.9748206841 512.74813669 3.912887874 -11.9798206841 467.710065431 3.912887874 -11.9848206841 480.380294984 3.912887874 -11.9898206841 492.830954314 3.912887874 -11.9948206841 512.796865151 3.912887874 -11.9998206841 527.457512834 3.912887874 -12.0048206841 541.979896173 3.912887874 -12.0098206841 552.424481886 3.912887874 -12.0148206841 553.56842632 3.912887874 -12.0198206841 549.893860797 3.912887874 -12.0248206841 557.156363226 3.912887874 -12.0298206841 553.816947753 3.912887874 -12.0348206841 561.28608289 3.912887874 -12.0398206841 562.593740541 3.912887874 -12.0448206841 569.17082739 3.912887874 -12.0498206841 571.603399307 3.912887874 -12.0548206841 575.957743576 3.912887874 -12.0598206841 579.719932697 3.912887874 -12.0648206841 582.186281548 3.912887874 -12.0698206841 581.349705289 3.912887874 -12.0748206841 580.064924228 3.912887874 -12.0798206841 576.640128732 3.912887874 -12.0848206841 573.509585905 3.912887874 -12.0898206841 566.406961638 3.912887874 -12.0948206841 556.57648873 3.912887874 -12.0998206841 549.383299066 3.912887874 -12.1048206841 542.991888555 3.912887874 -12.1098206841 539.558030578 3.912887874 -12.1148206841 535.127965626 3.912887874 -12.1198206841 532.675053767 3.912887874 -12.1248206841 531.945082891 3.912887874 -12.1298206841 530.788647615 3.912887874 -12.1348206841 543.215629911 3.912887874 -12.1398206841 546.345687125 3.912887874 -12.1448206841 553.761022346 3.912887874 -12.1498206841 567.031399478 3.912887874 -12.1548206841 581.247050053 3.912887874 -12.1598206841 597.665728285 3.912887874 -12.1648206841 613.448618614 3.912887874 -12.1698206841 624.491037644 3.912887874 -12.1748206841 650.732215766 3.912887874 -12.1798206841 666.21548424 3.912887874 -12.1848206841 682.752109667 3.912887874 -12.1898206841 699.419988693 3.912887874 -12.1948206841 718.965132517 3.912887874 -12.1998206841 738.777931975 3.912887874 -12.2048206841 753.707364867 3.912887874 -12.2098206841 771.337943706 3.912887874 -12.2148206841 782.2174347 3.912887874 -12.2198206841 797.160975657 3.912887874 -12.2248206841 816.857916583 3.912887874 -12.2298206841 826.978374254 3.912887874 -12.2348206841 843.281774469 3.912887874 -12.2398206841 853.550044627 3.912887874 -12.2448206841 883.691612937 3.912887874 -12.2498206841 901.226735125 3.912887874 -12.2548206841 884.778076902 3.912887874 -12.2598206841 899.278736682 3.912887874 -12.2648206841 914.404931312 3.912887874 -12.2698206841 921.477203499 3.912887874 -12.2748206841 886.872672792 3.912887874 -12.2798206841 892.031803206 3.912887874 -12.2848206841 859.449197056 3.912887874 -12.2898206841 879.624218527 3.912887874 -12.2948206841 848.765898848 3.912887874 -12.2998206841 807.915157727 3.912887874 -12.3048206841 757.534591488 3.912887874 -12.3098206841 707.68838884 3.912887874 -12.3148206841 675.5668643 3.912887874 -12.3198206841 643.209416787 3.912887874 -12.3248206841 616.477378523 3.912887874 -12.3298206841 594.296646966 3.912887874 -12.3348206841 563.116233018 3.912887874 -12.3398206841 548.511441185 3.912887874 -12.3448206841 523.015974477 3.912887874 -12.3498206841 507.8715047 3.912887874 -12.3548206841 490.246394078 3.912887874 -12.3598206841 465.585492869 3.912887874 -12.3648206841 437.046527115 3.912887874 -12.3698206841 410.872438095 3.912887874 -12.3748206841 403.00223141 3.912887874 -12.3798206841 395.849455376 3.912887874 -12.3848206841 388.017294232 3.912887874 -12.3898206841 393.261739842 3.912887874 -12.3948206841 398.899043519 3.912887874 -12.3998206841 399.300560756 3.912887874 -12.4048206841 401.927350993 3.912887874 -12.4098206841 396.121592743 3.912887874 -12.4148206841 393.822137297 3.912887874 -12.4198206841 391.907942118 3.912887874 -12.4248206841 391.760537393 3.912887874 -12.4298206841 395.279379222 3.912887874 -12.4348206841 405.717717821 3.912887874 -12.4398206841 415.248551575 3.912887874 -12.4448206841 423.174252806 3.912887874 -12.4498206841 428.803692665 3.912887874 -12.4548206841 435.336796396 3.912887874 -12.4598206841 443.743090507 3.912887874 -12.4648206841 433.604436111 3.912887874 -12.4698206841 429.240181122 3.912887874 -12.4748206841 418.977747152 3.912887874 -12.4798206841 406.616759554 3.912887874 -12.4848206841 394.873354725 3.912887874 -12.4898206841 387.784902122 3.912887874 -12.4948206841 383.916367033 3.912887874 -12.4998206841 380.356198321 3.912887874 -12.5048206841 374.953099722 3.912887874 -12.5098206841 374.858735317 3.912887874 -12.5148206841 372.196982134 3.912887874 -12.5198206841 366.023680269 3.912887874 -12.5248206841 366.661118995 3.912887874 -12.5298206841 360.433351706 3.912887874 -12.5348206841 358.691826834 3.912887874 -12.5398206841 357.585110549 3.912887874 -12.5448206841 356.268505867 3.912887874 -12.5498206841 357.66476615 3.912887874 -12.5548206841 363.055376085 3.912887874 -12.5598206841 360.759811274 3.912887874 -12.5648206841 367.736089201 3.912887874 -12.5698206841 365.36400804 3.912887874 -12.5748206841 363.736282468 3.912887874 -12.5798206841 359.189730925 3.912887874 -12.5848206841 354.42438795 3.912887874 -12.5898206841 352.880195785 3.912887874 -12.5948206841 351.202758807 3.912887874 -12.5998206841 352.00669432 3.912887874 -12.6048206841 349.145676014 3.912887874 -12.6098206841 349.563545286 3.912887874 -12.6148206841 340.934702601 3.912887874 -12.6198206841 331.946206982 3.912887874 -12.6248206841 328.853216987 3.912887874 -12.6298206841 321.490283975 3.912887874 -12.6348206841 315.399380438 3.912887874 -12.6398206841 310.069210572 3.912887874 -12.6448206841 304.808258068 3.912887874 -12.6498206841 296.376893592 3.912887874 -12.6548206841 288.657534777 3.912887874 -12.6598206841 280.057603278 3.912887874 -12.6648206841 276.65719921 3.912887874 -12.6698206841 272.682000132 3.912887874 -12.6748206841 269.668220451 3.912887874 -12.6798206841 267.483903291 3.912887874 -12.6848206841 263.12244645 3.912887874 -12.6898206841 259.624970362 3.912887874 -12.6948206841 256.861786488 3.912887874 -12.6998206841 250.434945069 3.912887874 -12.7048206841 246.890875316 3.912887874 -12.7098206841 242.099415138 3.912887874 -12.7148206841 238.548605701 3.912887874 -12.7198206841 232.769554642 3.912887874 -12.7248206841 229.581649938 3.912887874 -12.7298206841 223.434339261 3.912887874 -12.7348206841 215.097558014 3.912887874 -12.7398206841 203.857139699 3.912887874 -12.7448206841 196.42080625 3.912887874 -12.7498206841 185.747599372 3.912887874 -12.7548206841 176.840729914 3.912887874 -12.7598206841 168.657934291 3.912887874 -12.7648206841 158.982900603 3.912887874 -12.7698206841 158.982900603 3.912887874 -12.7748206841 149.870105928 3.912887874 -12.7798206841 141.67916548 3.912887874 -12.7848206841 126.277754197 3.912887874 -12.7898206841 107.304899936 3.912887874 -12.7948206841 96.6693381761 3.912887874 -12.7998206841 87.519145486 3.912887874 -12.8048206841 78.0246160378 3.912887874 -12.8098206841 71.8636329289 3.912887874 -12.8148206841 69.9414615267 3.912887874 -12.8198206841 65.089313674 3.912887874 -12.8248206841 56.9833696594 3.912887874 -12.8298206841 48.120052182 3.912887874 -12.8348206841 34.2227336537 3.912887874 -12.8398206841 16.8079292681 3.912887874 -12.8448206841 6.73579479872 3.912887874 -12.8498206841 -12.1387742363 3.912887874 -12.8548206841 -29.9758952382 3.912887874 -12.8598206841 -47.6285471807 3.912887874 -12.8648206841 -62.7508259412 3.912887874 -12.8698206841 -70.0939005484 3.912887874 -12.8748206841 -73.0451843455 3.912887874 -12.8798206841 -73.0451843455 3.912887874 -12.8848206841 -73.0451843455 3.912887874 -12.8898206841 -73.0451843455 3.912887874 -12.8948206841 -73.0451843455 3.912887874 -12.8998206841 -73.0451843455 3.912887874 -12.9048206841 -73.0451843455 3.912887874 -12.9098206841 -73.0451843455 3.912887874 -12.9148206841 -73.0451843455 3.912887874 -12.9198206841 -73.0451843455 3.912887874 -12.9248206841 -73.0451843455 3.912887874 -12.9298206841 -73.0451843455 3.912887874 -12.9348206841 -73.0451843455 3.912887874 -12.9398206841 -73.0451843455 3.912887874 -12.9448206841 -73.0451843455 3.912887874 -12.9498206841 -73.0451843455 3.912887874 -12.9548206841 -73.0451843455 3.912887874 -12.9598206841 -73.0451843455 3.912887874 -12.9648206841 -73.0451843455 3.912887874 -12.9698206841 -73.0451843455 3.912887874 -12.9748206841 -73.0451843455 3.912887874 -12.9798206841 -73.0451843455 3.912887874 -12.9848206841 -73.0451843455 3.912887874 -12.9898206841 -73.0451843455 3.912887874 -12.9948206841 -73.0451843455 3.912887874 -12.9998206841 -73.0451843455 3.912887874 -13.0048206841 -73.0451843455 3.912887874 -13.0098206841 -73.0451843455 3.912887874 -13.0148206841 -73.0451843455 3.912887874 -13.0198206841 -73.0451843455 3.912887874 -13.0248206841 -73.0451843455 3.912887874 -13.0298206841 -73.0451843455 3.912887874 -13.0348206841 -73.0451843455 3.912887874 -13.0398206841 -73.0451843455 3.912887874 -13.0448206841 -73.0451843455 3.912887874 -13.0498206841 -73.0451843455 3.912887874 -13.0548206841 -73.0451843455 3.912887874 -13.0598206841 -73.0451843455 3.912887874 -13.0648206841 -73.0451843455 3.912887874 -13.0698206841 -73.0451843455 3.912887874 -13.0748206841 -73.0451843455 3.912887874 -13.0798206841 -73.0451843455 3.912887874 -13.0848206841 -73.0451843455 3.912887874 -13.0898206841 -73.0451843455 3.912887874 -13.0948206841 -73.0451843455 3.912887874 -13.0998206841 -73.0451843455 3.912887874 -13.1048206841 -73.0451843455 3.912887874 -13.1098206841 -73.0451843455 3.912887874 -13.1148206841 -73.0451843455 3.912887874 -13.1198206841 -73.0451843455 3.912887874 -13.1248206841 -73.0451843455 3.912887874 -13.1298206841 -73.0451843455 3.912887874 -13.1348206841 -73.0451843455 3.912887874 -13.1398206841 -73.0451843455 3.912887874 -13.1448206841 -73.0451843455 3.912887874 -13.1498206841 -73.0451843455 3.912887874 -13.1548206841 -73.0451843455 3.912887874 -13.1598206841 -73.0451843455 3.912887874 -13.1648206841 -73.0451843455 3.912887874 -13.1698206841 -73.0451843455 3.912887874 -13.1748206841 -73.0451843455 3.912887874 -13.1798206841 -73.0451843455 3.912887874 -13.1848206841 -73.0451843455 3.912887874 -13.1898206841 -73.0451843455 3.912887874 -13.1948206841 -73.0451843455 3.912887874 -13.1998206841 -73.0451843455 3.912887874 -13.2048206841 -73.0451843455 3.912887874 -13.2098206841 -73.0451843455 3.912887874 -13.2148206841 -73.0451843455 3.912887874 -13.2198206841 -73.0451843455 3.912887874 -13.2248206841 -73.0451843455 3.912887874 -13.2298206841 -73.0451843455 3.912887874 -13.2348206841 -73.0451843455 3.912887874 -13.2398206841 -73.0451843455 3.912887874 -13.2448206841 -73.0451843455 3.912887874 -13.2498206841 -73.0451843455 3.912887874 -13.2548206841 -73.0451843455 3.912887874 -13.2598206841 -73.0451843455 3.912887874 -13.2648206841 -73.0451843455 3.912887874 -13.2698206841 -73.0451843455 3.912887874 -13.2748206841 -73.0451843455 3.912887874 -13.2798206841 -73.0451843455 3.912887874 -13.2848206841 -73.0451843455 3.912887874 -13.2898206841 -73.0451843455 3.912887874 -13.2948206841 -73.0451843455 3.912887874 -13.2998206841 -73.0451843455 3.912887874 -13.3048206841 -73.0451843455 3.912887874 -13.3098206841 -73.0451843455 3.912887874 -13.3148206841 -73.0451843455 3.912887874 -13.3198206841 -73.0451843455 3.912887874 -13.3248206841 -73.0451843455 3.912887874 -13.3298206841 -73.0451843455 3.912887874 -13.3348206841 -73.0451843455 3.912887874 -13.3398206841 -73.0451843455 3.912887874 -13.3448206841 -73.0451843455 3.912887874 -13.3498206841 -73.0451843455 3.912887874 -13.3548206841 -73.0451843455 3.912887874 -13.3598206841 -73.0451843455 3.912887874 -13.3648206841 -73.0451843455 3.912887874 -13.3698206841 -73.0451843455 3.912887874 -13.3748206841 -73.0451843455 3.912887874 -13.3798206841 -73.0451843455 3.912887874 -13.3848206841 -73.0451843455 3.912887874 -13.3898206841 -73.0451843455 3.912887874 -13.3948206841 -73.0451843455 3.912887874 -13.3998206841 -73.0451843455 3.912887874 -13.4048206841 -73.0451843455 3.912887874 -13.4098206841 -73.0451843455 3.912887874 -13.4148206841 -73.0451843455 3.912887874 -13.4198206841 -73.0451843455 3.912887874 -13.4248206841 -73.0451843455 3.912887874 -13.4298206841 -73.0451843455 3.912887874 -13.4348206841 -73.0451843455 3.912887874 -13.4398206841 -73.0451843455 3.912887874 -13.4448206841 -73.0451843455 3.912887874 -13.4498206841 -73.0451843455 3.912887874 -13.4548206841 -73.0451843455 3.912887874 -13.4598206841 -73.0451843455 3.912887874 -13.4648206841 -73.0451843455 3.912887874 -13.4698206841 -73.0451843455 3.912887874 -13.4748206841 -73.0451843455 3.912887874 -13.4798206841 -73.0451843455 3.912887874 -13.4848206841 -73.0451843455 3.912887874 -13.4898206841 -73.0451843455 3.912887874 -13.4948206841 -73.0451843455 3.912887874 -13.4998206841 -73.0451843455 3.912887874 -13.5048206841 -73.0451843455 3.912887874 -13.5098206841 -73.0451843455 3.912887874 -13.5148206841 -73.0451843455 3.912887874 -13.5198206841 -73.0451843455 3.912887874 -13.5248206841 -73.0451843455 3.912887874 -13.5298206841 -73.0451843455 3.912887874 -13.5348206841 -73.0451843455 3.912887874 -13.5398206841 -73.0451843455 3.912887874 -13.5448206841 -73.0451843455 3.912887874 -13.5498206841 -73.0451843455 3.912887874 -13.5548206841 -73.0451843455 3.912887874 -13.5598206841 -73.0451843455 3.912887874 -13.5648206841 -73.0451843455 3.912887874 -13.5698206841 -73.0451843455 3.912887874 -13.5748206841 -73.0451843455 3.912887874 -13.5798206841 -73.0451843455 3.912887874 -13.5848206841 -73.0451843455 3.912887874 -13.5898206841 -73.0451843455 3.912887874 -13.5948206841 -73.0451843455 3.912887874 -13.5998206841 -73.0451843455 3.912887874 -13.6048206841 -73.0451843455 3.912887874 -13.6098206841 -73.0451843455 3.912887874 -13.6148206841 -73.0451843455 3.912887874 -13.6198206841 -73.0451843455 3.912887874 -13.6248206841 -73.0451843455 3.912887874 -13.6298206841 -73.0451843455 3.912887874 -13.6348206841 -73.0451843455 3.912887874 -13.6398206841 -73.0451843455 3.912887874 -13.6448206841 -73.0451843455 3.912887874 -13.6498206841 -73.0451843455 3.912887874 -13.6548206841 -73.0451843455 3.912887874 -13.6598206841 -73.0451843455 3.912887874 -13.6648206841 -73.0451843455 3.912887874 -13.6698206841 -73.0451843455 3.912887874 -13.6748206841 -73.0451843455 3.912887874 -13.6798206841 -73.0451843455 3.912887874 -13.6848206841 -73.0451843455 3.912887874 -13.6898206841 -73.0451843455 3.912887874 -13.6948206841 -73.0451843455 3.912887874 -13.6998206841 -73.0451843455 3.912887874 -13.7048206841 -73.0451843455 3.912887874 -13.7098206841 -73.0451843455 3.912887874 -13.7148206841 -73.0451843455 3.912887874 -13.7198206841 -73.0451843455 3.912887874 -13.7248206841 -73.0451843455 3.912887874 -13.7298206841 -73.0451843455 3.912887874 -13.7348206841 -73.0451843455 3.912887874 -13.7398206841 -73.0451843455 3.912887874 -13.7448206841 -73.0451843455 3.912887874 -13.7498206841 -73.0451843455 3.912887874 -13.7548206841 -73.0451843455 3.912887874 -13.7598206841 -73.0451843455 3.912887874 -13.7648206841 -73.0451843455 3.912887874 -13.7698206841 -73.0451843455 3.912887874 -13.7748206841 -73.0451843455 3.912887874 -13.7798206841 -73.0451843455 3.912887874 -13.7848206841 -73.0451843455 3.912887874 -13.7898206841 -73.0451843455 3.912887874 -13.7948206841 -73.0451843455 3.912887874 -13.7998206841 -73.0451843455 3.912887874 -13.8048206841 -73.0451843455 3.912887874 -13.8098206841 -73.0451843455 3.912887874 -13.8148206841 -73.0451843455 3.912887874 -13.8198206841 -73.0451843455 3.912887874 -13.8248206841 -73.0451843455 3.912887874 -13.8298206841 -73.0451843455 3.912887874 -13.8348206841 875.48306836 3.912887874 -13.8398206841 1231.61667783 3.912887874 -13.8448206841 1338.98376269 3.912887874 -13.8498206841 1465.59646288 3.912887874 -13.8548206841 1441.45835286 3.912887874 -13.8598206841 1517.09722775 3.912887874 -13.8648206841 1400.25564503 3.912887874 -13.8698206841 1245.00255756 3.912887874 -13.8748206841 1069.47056126 3.912887874 -13.8798206841 956.523372381 3.912887874 -13.8848206841 830.716508498 3.912887874 -13.8898206841 674.924173278 3.912887874 -13.8948206841 613.944788728 3.912887874 -13.8998206841 529.268664875 3.912887874 -13.9048206841 469.846238165 3.912887874 -13.9098206841 409.67176799 3.912887874 -13.9148206841 411.470642963 3.912887874 -13.9198206841 398.052824694 3.912887874 -13.9248206841 410.419538467 3.912887874 -13.9298206841 438.093864542 3.912887874 -13.9348206841 468.644124138 3.912887874 -13.9398206841 503.073508626 3.912887874 -13.9448206841 531.161084863 3.912887874 -13.9498206841 556.326252104 3.912887874 -13.9548206841 581.198976803 3.912887874 -13.9598206841 595.854453036 3.912887874 -13.9648206841 607.336172542 3.912887874 -13.9698206841 611.856536586 3.912887874 -13.9748206841 610.872536141 3.912887874 -13.9798206841 610.60611013 3.912887874 -13.9848206841 603.411859247 3.912887874 -13.9898206841 596.176046913 3.912887874 -13.9948206841 587.630757851 3.912887874 -13.9998206841 583.890255195 3.912887874 -14.0048206841 575.63066231 3.912887874 -14.0098206841 569.459307487 3.912887874 -14.0148206841 568.322842785 3.912887874 -14.0198206841 572.667729637 3.912887874 -14.0248206841 573.685697665 3.912887874 -14.0298206841 578.620753002 3.912887874 -14.0348206841 580.949914521 3.912887874 -14.0398206841 582.982157577 3.912887874 -14.0448206841 589.399506096 3.912887874 -14.0498206841 594.444153923 3.912887874 -14.0548206841 598.997902 3.912887874 -14.0598206841 607.89387867 3.912887874 -14.0648206841 614.206525453 3.912887874 -14.0698206841 624.571286067 3.912887874 -14.0748206841 634.927679654 3.912887874 -14.0798206841 643.262204714 3.912887874 -14.0848206841 655.830410497 3.912887874 -14.0898206841 665.072442887 3.912887874 -14.0948206841 679.908040442 3.912887874 -14.0998206841 694.177600304 3.912887874 -14.1048206841 704.763264539 3.912887874 -14.1098206841 686.290789138 3.912887874 -14.1148206841 727.237084136 3.912887874 -14.1198206841 737.67890897 3.912887874 -14.1248206841 756.158073365 3.912887874 -14.1298206841 771.712933809 3.912887874 -14.1348206841 800.660911691 3.912887874 -14.1398206841 826.556920228 3.912887874 -14.1448206841 842.81270383 3.912887874 -14.1498206841 867.744140561 3.912887874 -14.1548206841 895.442374933 3.912887874 -14.1598206841 862.212454378 3.912887874 -14.1648206841 890.141906842 3.912887874 -14.1698206841 876.751083297 3.912887874 -14.1748206841 856.680859524 3.912887874 -14.1798206841 842.803313825 3.912887874 -14.1848206841 816.150297568 3.912887874 -14.1898206841 822.911584722 3.912887874 -14.1948206841 788.497065618 3.912887874 -14.1998206841 756.878943827 3.912887874 -14.2048206841 732.141810534 3.912887874 -14.2098206841 681.380374055 3.912887874 -14.2148206841 649.492900979 3.912887874 -14.2198206841 610.410764029 3.912887874 -14.2248206841 576.874590725 3.912887874 -14.2298206841 539.600099529 3.912887874 -14.2348206841 526.465122803 3.912887874 -14.2398206841 512.391327945 3.912887874 -14.2448206841 503.474854922 3.912887874 -14.2498206841 473.682979935 3.912887874 -14.2548206841 422.232648308 3.912887874 -14.2598206841 424.673020781 3.912887874 -14.2648206841 426.199399881 3.912887874 -14.2698206841 420.920375028 3.912887874 -14.2748206841 414.301071989 3.912887874 -14.2798206841 416.136769129 3.912887874 -14.2848206841 402.57537572 3.912887874 -14.2898206841 399.341832806 3.912887874 -14.2948206841 394.48951637 3.912887874 -14.2998206841 386.041157894 3.912887874 -14.3048206841 375.618752748 3.912887874 -14.3098206841 383.538256713 3.912887874 -14.3148206841 382.744897018 3.912887874 -14.3198206841 376.955014292 3.912887874 -14.3248206841 372.733735874 3.912887874 -14.3298206841 367.657271006 3.912887874 -14.3348206841 365.72271327 3.912887874 -14.3398206841 377.212933145 3.912887874 -14.3448206841 384.377513372 3.912887874 -14.3498206841 388.076594012 3.912887874 -14.3548206841 396.012151998 3.912887874 -14.3598206841 402.972435256 3.912887874 -14.3648206841 412.24724007 3.912887874 -14.3698206841 418.803148907 3.912887874 -14.3748206841 427.939555968 3.912887874 -14.3798206841 424.071680579 3.912887874 -14.3848206841 434.044462238 3.912887874 -14.3898206841 431.050641474 3.912887874 -14.3948206841 430.739180969 3.912887874 -14.3998206841 424.882419736 3.912887874 -14.4048206841 413.618488405 3.912887874 -14.4098206841 413.618488405 3.912887874 -14.4148206841 403.84354451 3.912887874 -14.4198206841 384.371172928 3.912887874 -14.4248206841 369.637001366 3.912887874 -14.4298206841 361.213355911 3.912887874 -14.4348206841 353.893193268 3.912887874 -14.4398206841 345.063506481 3.912887874 -14.4448206841 339.180901228 3.912887874 -14.4498206841 337.495458585 3.912887874 -14.4548206841 332.615254175 3.912887874 -14.4598206841 335.159248358 3.912887874 -14.4648206841 338.024916183 3.912887874 -14.4698206841 339.267577181 3.912887874 -14.4748206841 340.936988865 3.912887874 -14.4798206841 343.818520008 3.912887874 -14.4848206841 349.46943906 3.912887874 -14.4898206841 355.637403677 3.912887874 -14.4948206841 354.866632897 3.912887874 -14.4998206841 351.50280063 3.912887874 -14.5048206841 347.812967042 3.912887874 -14.5098206841 343.472557564 3.912887874 -14.5148206841 342.936803117 3.912887874 -14.5198206841 337.633508718 3.912887874 -14.5248206841 326.26607288 3.912887874 -14.5298206841 317.594061658 3.912887874 -14.5348206841 310.95895985 3.912887874 -14.5398206841 305.472332265 3.912887874 -14.5448206841 291.407821835 3.912887874 -14.5498206841 286.424894833 3.912887874 -14.5548206841 279.793456082 3.912887874 -14.5598206841 272.473647711 3.912887874 -14.5648206841 266.571718576 3.912887874 -14.5698206841 261.315577537 3.912887874 -14.5748206841 250.934015884 3.912887874 -14.5798206841 242.36208467 3.912887874 -14.5848206841 232.339713775 3.912887874 -14.5898206841 223.536742852 3.912887874 -14.5948206841 227.93579004 3.912887874 -14.5998206841 218.871052554 3.912887874 -14.6048206841 215.490228075 3.912887874 -14.6098206841 212.230795937 3.912887874 -14.6148206841 207.725102078 3.912887874 -14.6198206841 207.27852084 3.912887874 -14.6248206841 201.64945155 3.912887874 -14.6298206841 195.013495035 3.912887874 -14.6348206841 196.1434797 3.912887874 -14.6398206841 185.43718115 3.912887874 -14.6448206841 177.434561054 3.912887874 -14.6498206841 169.254097559 3.912887874 -14.6548206841 159.711778424 3.912887874 -14.6598206841 150.532867308 3.912887874 -14.6648206841 132.412679197 3.912887874 -14.6698206841 122.00802363 3.912887874 -14.6748206841 114.589722562 3.912887874 -14.6798206841 109.763765543 3.912887874 -14.6848206841 105.032538029 3.912887874 -14.6898206841 96.0197875389 3.912887874 -14.6948206841 88.6424294061 3.912887874 -14.6998206841 78.156807677 3.912887874 -14.7048206841 67.7026645494 3.912887874 -14.7098206841 57.6485816356 3.912887874 -14.7148206841 50.1890121171 3.912887874 -14.7198206841 42.1862167769 3.912887874 -14.7248206841 33.4126551067 3.912887874 -14.7298206841 24.1974771797 3.912887874 -14.7348206841 17.8444598428 3.912887874 -14.7398206841 -11.0655562748 3.912887874 -14.7448206841 -23.4652576239 3.912887874 -14.7498206841 -26.164560673 3.912887874 -14.7548206841 -27.3505495491 3.912887874 -14.7598206841 -37.2682052026 3.912887874 -14.7648206841 -46.1808602065 3.912887874 -14.7698206841 -57.5053853015 3.912887874 -14.7748206841 -89.4845837792 3.912887874 -14.7798206841 -89.4845837792 3.912887874 -14.7848206841 -89.4845837792 3.912887874 -14.7898206841 -89.4845837792 3.912887874 -14.7948206841 -89.4845837792 3.912887874 -14.7998206841 -89.4845837792 3.912887874 -14.8048206841 -89.4845837792 3.912887874 -14.8098206841 -89.4845837792 3.912887874 -14.8148206841 -89.4845837792 3.912887874 -14.8198206841 -89.4845837792 3.912887874 -14.8248206841 -89.4845837792 3.912887874 -14.8298206841 -89.4845837792 3.912887874 -14.8348206841 -89.4845837792 3.912887874 -14.8398206841 -89.4845837792 3.912887874 -14.8448206841 -89.4845837792 3.912887874 -14.8498206841 -89.4845837792 3.912887874 -14.8548206841 -89.4845837792 3.912887874 -14.8598206841 -89.4845837792 3.912887874 -14.8648206841 -89.4845837792 3.912887874 -14.8698206841 -89.4845837792 3.912887874 -14.8748206841 -89.4845837792 3.912887874 -14.8798206841 -89.4845837792 3.912887874 -14.8848206841 -89.4845837792 3.912887874 -14.8898206841 -89.4845837792 3.912887874 -14.8948206841 -89.4845837792 3.912887874 -14.8998206841 -89.4845837792 3.912887874 -14.9048206841 -89.4845837792 3.912887874 -14.9098206841 -89.4845837792 3.912887874 -14.9148206841 -89.4845837792 3.912887874 -14.9198206841 -89.4845837792 3.912887874 -14.9248206841 -89.4845837792 3.912887874 -14.9298206841 -89.4845837792 3.912887874 -14.9348206841 -89.4845837792 3.912887874 -14.9398206841 -89.4845837792 3.912887874 -14.9448206841 -89.4845837792 3.912887874 -14.9498206841 -89.4845837792 3.912887874 -14.9548206841 -89.4845837792 3.912887874 -14.9598206841 -89.4845837792 3.912887874 -14.9648206841 -89.4845837792 3.912887874 -14.9698206841 -89.4845837792 3.912887874 -14.9748206841 -89.4845837792 3.912887874 -14.9798206841 -89.4845837792 3.912887874 -14.9848206841 -89.4845837792 3.912887874 -14.9898206841 -89.4845837792 3.912887874 -14.9948206841 -89.4845837792 3.912887874 -14.9998206841 -89.4845837792 3.912887874 -15.0048206841 -89.4845837792 3.912887874 -15.0098206841 -89.4845837792 3.912887874 -15.0148206841 -89.4845837792 3.912887874 -15.0198206841 -89.4845837792 3.912887874 -15.0248206841 -89.4845837792 3.912887874 -15.0298206841 -89.4845837792 3.912887874 -15.0348206841 -89.4845837792 3.912887874 -15.0398206841 -89.4845837792 3.912887874 -15.0448206841 -89.4845837792 3.912887874 -15.0498206841 -89.4845837792 3.912887874 -15.0548206841 -89.4845837792 3.912887874 -15.0598206841 -89.4845837792 3.912887874 -15.0648206841 -89.4845837792 3.912887874 -15.0698206841 -89.4845837792 3.912887874 -15.0748206841 -89.4845837792 3.912887874 -15.0798206841 -89.4845837792 3.912887874 -15.0848206841 -89.4845837792 3.912887874 -15.0898206841 -89.4845837792 3.912887874 -15.0948206841 -89.4845837792 3.912887874 -15.0998206841 -89.4845837792 3.912887874 -15.1048206841 -89.4845837792 3.912887874 -15.1098206841 -89.4845837792 3.912887874 -15.1148206841 -89.4845837792 3.912887874 -15.1198206841 -89.4845837792 3.912887874 -15.1248206841 -89.4845837792 3.912887874 -15.1298206841 -89.4845837792 3.912887874 -15.1348206841 -89.4845837792 3.912887874 -15.1398206841 -89.4845837792 3.912887874 -15.1448206841 -89.4845837792 3.912887874 -15.1498206841 -89.4845837792 3.912887874 -15.1548206841 -89.4845837792 3.912887874 -15.1598206841 -89.4845837792 3.912887874 -15.1648206841 -89.4845837792 3.912887874 -15.1698206841 -89.4845837792 3.912887874 -15.1748206841 -89.4845837792 3.912887874 -15.1798206841 -89.4845837792 3.912887874 -15.1848206841 -89.4845837792 3.912887874 -15.1898206841 -89.4845837792 3.912887874 -15.1948206841 -89.4845837792 3.912887874 -15.1998206841 -89.4845837792 3.912887874 -15.2048206841 -89.4845837792 3.912887874 -15.2098206841 -89.4845837792 3.912887874 -15.2148206841 -89.4845837792 3.912887874 -15.2198206841 -89.4845837792 3.912887874 -15.2248206841 -89.4845837792 3.912887874 -15.2298206841 -89.4845837792 3.912887874 -15.2348206841 -89.4845837792 3.912887874 -15.2398206841 -89.4845837792 3.912887874 -15.2448206841 -89.4845837792 3.912887874 -15.2498206841 -89.4845837792 3.912887874 -15.2548206841 -89.4845837792 3.912887874 -15.2598206841 -89.4845837792 3.912887874 -15.2648206841 -89.4845837792 3.912887874 -15.2698206841 -89.4845837792 3.912887874 -15.2748206841 -89.4845837792 3.912887874 -15.2798206841 -89.4845837792 3.912887874 -15.2848206841 -89.4845837792 3.912887874 -15.2898206841 -89.4845837792 3.912887874 -15.2948206841 -89.4845837792 3.912887874 -15.2998206841 -89.4845837792 3.912887874 -15.3048206841 -89.4845837792 3.912887874 -15.3098206841 -89.4845837792 3.912887874 -15.3148206841 -89.4845837792 3.912887874 -15.3198206841 -89.4845837792 3.912887874 -15.3248206841 -89.4845837792 3.912887874 -15.3298206841 -89.4845837792 3.912887874 -15.3348206841 -89.4845837792 3.912887874 -15.3398206841 -89.4845837792 3.912887874 -15.3448206841 -89.4845837792 3.912887874 -15.3498206841 -89.4845837792 3.912887874 -15.3548206841 -89.4845837792 3.912887874 -15.3598206841 -89.4845837792 3.912887874 -15.3648206841 -89.4845837792 3.912887874 -15.3698206841 -89.4845837792 3.912887874 -15.3748206841 -89.4845837792 3.912887874 -15.3798206841 -89.4845837792 3.912887874 -15.3848206841 -89.4845837792 3.912887874 -15.3898206841 -89.4845837792 3.912887874 -15.3948206841 -89.4845837792 3.912887874 -15.3998206841 -89.4845837792 3.912887874 -15.4048206841 -89.4845837792 3.912887874 -15.4098206841 -89.4845837792 3.912887874 -15.4148206841 -89.4845837792 3.912887874 -15.4198206841 -89.4845837792 3.912887874 -15.4248206841 -89.4845837792 3.912887874 -15.4298206841 -89.4845837792 3.912887874 -15.4348206841 -89.4845837792 3.912887874 -15.4398206841 -89.4845837792 3.912887874 -15.4448206841 -89.4845837792 3.912887874 -15.4498206841 -89.4845837792 3.912887874 -15.4548206841 -89.4845837792 3.912887874 -15.4598206841 -89.4845837792 3.912887874 -15.4648206841 -89.4845837792 3.912887874 -15.4698206841 -89.4845837792 3.912887874 -15.4748206841 -89.4845837792 3.912887874 -15.4798206841 -89.4845837792 3.912887874 -15.4848206841 -89.4845837792 3.912887874 -15.4898206841 -89.4845837792 3.912887874 -15.4948206841 -89.4845837792 3.912887874 -15.4998206841 -89.4845837792 3.912887874 -15.5048206841 -89.4845837792 3.912887874 -15.5098206841 -89.4845837792 3.912887874 -15.5148206841 -89.4845837792 3.912887874 -15.5198206841 -89.4845837792 3.912887874 -15.5248206841 -89.4845837792 3.912887874 -15.5298206841 -89.4845837792 3.912887874 -15.5348206841 -89.4845837792 3.912887874 -15.5398206841 -89.4845837792 3.912887874 -15.5448206841 -89.4845837792 3.912887874 -15.5498206841 -89.4845837792 3.912887874 -15.5548206841 -89.4845837792 3.912887874 -15.5598206841 -89.4845837792 3.912887874 -15.5648206841 -89.4845837792 3.912887874 -15.5698206841 -89.4845837792 3.912887874 -15.5748206841 -89.4845837792 3.912887874 -15.5798206841 -89.4845837792 3.912887874 -15.5848206841 -89.4845837792 3.912887874 -15.5898206841 -89.4845837792 3.912887874 -15.5948206841 -89.4845837792 3.912887874 -15.5998206841 -89.4845837792 3.912887874 -15.6048206841 -89.4845837792 3.912887874 -15.6098206841 -89.4845837792 3.912887874 -15.6148206841 -89.4845837792 3.912887874 -15.6198206841 -89.4845837792 3.912887874 -15.6248206841 -89.4845837792 3.912887874 -15.6298206841 -89.4845837792 3.912887874 -15.6348206841 -89.4845837792 3.912887874 -15.6398206841 -89.4845837792 3.912887874 -15.6448206841 -89.4845837792 3.912887874 -15.6498206841 -89.4845837792 3.912887874 -15.6548206841 -89.4845837792 3.912887874 -15.6598206841 -89.4845837792 3.912887874 -15.6648206841 -89.4845837792 3.912887874 -15.6698206841 -89.4845837792 3.912887874 -15.6748206841 -89.4845837792 3.912887874 -15.6798206841 -89.4845837792 3.912887874 -15.6848206841 -89.4845837792 3.912887874 -15.6898206841 -89.4845837792 3.912887874 -15.6948206841 -89.4845837792 3.912887874 -15.6998206841 -89.4845837792 3.912887874 -15.7048206841 -89.4845837792 3.912887874 -15.7098206841 -89.4845837792 3.912887874 -15.7148206841 -89.4845837792 3.912887874 -15.7198206841 -89.4845837792 3.912887874 -15.7248206841 930.391916571 3.912887874 -15.7298206841 322.941669033 3.912887874 -15.7348206841 101.825848616 3.912887874 -15.7398206841 119.781740504 3.912887874 diff --git a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/test_mem.py b/applications/PFEMapplication/test_examples/sloshing_experimental.gid/test_mem.py deleted file mode 100644 index e80fe1930dfd..000000000000 --- a/applications/PFEMapplication/test_examples/sloshing_experimental.gid/test_mem.py +++ /dev/null @@ -1,176 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.IncompressibleFluidApplication import * -import math - - -def SelectSolidNodes(model_part, solid_nodes): - print("in SelectSolidNodes") - for node in model_part.Nodes: - if(node.GetSolutionStepValue(IS_STRUCTURE) == 1): - solid_nodes.append(node) - print(solid_nodes) - - -def FindNode(node_list, x, y, z): - for node in node_list: - a = (node.X - x) ** 2 - a = a + (node.Y - y) * (node.Y - y) - a = a + (node.Z - z) * (node.Z - z) - if (a < 0.0000001): - return node - - -def PrintForce(time, filename, node1, node2): - print("in print force", time) - outstring = str(time) + " " - outstring += str(node1.GetSolutionStepValue(PRESSURE)) + " " - outstring += str(node2.GetSolutionStepValue(PRESSURE)) + "\n" - filename.write(outstring) - - -def MoveSolidNodes(alpha_max_grad, T, Dt, time, solid_nodes, xc, yc): - dist = Vector(3) - out = Vector(3) - disp = Vector(3) - vel = Vector(3) - center = Vector(3) - center[0] = xc - center[1] = yc - center[2] = 0.0 - - # calculate rotation matrix - alpha_rad = alpha_max_grad * 3.1415 / 180.0 - w = 2.0 * 3.1415 / T - # incremental angle - alpha = alpha_rad * (math.sin(w * time) - math.sin(w * (time - Dt))); - - Rot = Matrix(3, 3) - Rot[0, 0] = math.cos(alpha) - Rot[0, 1] = -math.sin(alpha) - Rot[0, 2] = 0.0 - Rot[1, 0] = math.sin(alpha) - Rot[1, 1] = math.cos(alpha) - Rot[1, 2] = 0.0 - Rot[2, 0] = 0.0; Rot[2, 1] = 0.0; Rot[2, 2] = 0.0 - - for i in range(0, len(solid_nodes)): - dist[0] = solid_nodes[i].X - dist[1] = solid_nodes[i].Y - dist[2] = 0.0 - dist = dist - center - - # calcualte incremental displacement - pos = Rot * dist + center - - disp[0] = pos[0] - solid_nodes[i].X; - disp[1] = pos[1] - solid_nodes[i].Y; - disp[2] = 0.0 - - # calculate vel - vel = disp / Dt - solid_nodes[i].SetSolutionStepValue(VELOCITY, 0, vel) - - # calcualte total displacement - step_in_the_past = 1 - old_disp = solid_nodes[i].GetSolutionStepValue(DISPLACEMENT, step_in_the_past) - disp = disp + old_disp - solid_nodes[i].SetSolutionStepValue(DISPLACEMENT, 0, disp) - - -# path for applications s -import sys -sys.path.append('/home/rrossi/kratos_cvs/applications/incompressible_fluid_application/python_scripts') - -kernel = Kernel() - -# -# defining the domain size -domain_size = 2 - -# -# -# attention!! order is crucial here!!! -# importing the applications library and adding them to the kernel -incompressible_fluid_application = KratosIncompressibleFluidApplication() -kernel.AddApplication(incompressible_fluid_application) - -# dynamic renumbering of variables to ensure consistency -kernel.Initialize() -kernel.InitializeApplication(incompressible_fluid_application); -# -# - -# defining a model part -model_part = ModelPart("FluidPart"); - -# adding of Variables to Model Part should be here when the "very fix container will be ready" - -# reading a model -gid_io = GidIO("sloshing_experimental", GiDPostMode.GiD_PostBinary) -gid_io.ReadMesh(model_part.GetMesh()) -print(model_part) - -# the buffer size should be set up here after the mesh is read for the first time -model_part.SetBufferSize(2) - -# importing the solver files -import pfem_solver -pfem_solver.AddVariables(model_part) - -# setting the limits of the bounding box -box_corner1 = Vector(3); box_corner1[0] = -1.5; box_corner1[1] = -1.5; box_corner1[2] = -0.5; -box_corner2 = Vector(3); box_corner2[0] = 1.5; box_corner2[1] = 1.5; box_corner2[2] = 0.1; - -# selecting the nodes for the motion of the gate -solid_nodes = [] -SelectSolidNodes(model_part, solid_nodes) - -# creating a fluid solver object -name = str("sloshing_experimental") - -# solver = pfem_solver.PFEMSolver(model_part,name,box_corner1,box_corner2,domain_size) -# pDiagPrecond = DiagonalPreconditioner() -# solver.pressure_linear_solver = CGSolver(1e-3, 5000,pDiagPrecond) -# solver.predictor_corrector = True -Mesher = TriGenModeler() - -Dt = 0.005 -nsteps = 6 -output_Dt = 0.05 -min_dt = 0.2 * Dt -max_dt = 2.0 * Dt -tmax = 0.35 - - -node_0_093 = FindNode(model_part.Nodes, 0.0, 0.093, 0.0) -node_0_299 = FindNode(model_part.Nodes, 0.0, 0.299, 0.0) - -scalarout = open("pressure_history.out", 'w') -scalarout.write("time (0.0,0.093) (0.0,0.299) \n") - -time = 0.0 -step = 0 -# for step in range(0,nsteps): -while (time < tmax): - step = step + 1 - new_Dt = Dt - - time = time + new_Dt - print("time = ", time, " new_Dt= ", new_Dt, " step = ", step) - - # time = Dt*step - model_part.CloneTimeStep(time) - - # moving the gate - alpha_max_grad = 4.0; - T = 1.91; - xc = 0.45; yc = 0.184; - MoveSolidNodes(alpha_max_grad, T, new_Dt, time, solid_nodes, xc, yc) - - print(time) - (Mesher).ReGenerateMesh(model_part, 1.5) - # print model_part.ProcessInfo()[TIME] - - # solving the fluid problem diff --git a/applications/ParticleMechanicsApplication/custom_constitutive/hencky_plastic_3d_law.cpp b/applications/ParticleMechanicsApplication/custom_constitutive/hencky_plastic_3d_law.cpp index 4b013e3fe34c..0d5729c856a6 100644 --- a/applications/ParticleMechanicsApplication/custom_constitutive/hencky_plastic_3d_law.cpp +++ b/applications/ParticleMechanicsApplication/custom_constitutive/hencky_plastic_3d_law.cpp @@ -280,7 +280,7 @@ void HenckyElasticPlastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& //5.-Almansi Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { // e= 0.5*(1-invbT*invb) this->CalculateAlmansiStrain(ElasticVariables.CauchyGreenMatrix, StrainVector); diff --git a/applications/ParticleMechanicsApplication/custom_constitutive/hyperelastic_viscoplastic_3D_law.cpp b/applications/ParticleMechanicsApplication/custom_constitutive/hyperelastic_viscoplastic_3D_law.cpp index d6ef253e8864..100192c6dc58 100644 --- a/applications/ParticleMechanicsApplication/custom_constitutive/hyperelastic_viscoplastic_3D_law.cpp +++ b/applications/ParticleMechanicsApplication/custom_constitutive/hyperelastic_viscoplastic_3D_law.cpp @@ -232,8 +232,8 @@ void HyperElasticViscoplastic3DLaw::CalculateMaterialResponsePK2 (Parameters& r Matrix& ConstitutiveMatrix = rValues.GetConstitutiveMatrix(); - //2.-Green-Lagrange Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + //2.-Green-Lagrange Strain: + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { TransformStrains (StrainVector, DeformationGradientF, StrainMeasure_Almansi, StrainMeasure_GreenLagrange); } @@ -355,7 +355,7 @@ void HyperElasticViscoplastic3DLaw::CalculateMaterialResponseKirchhoff (Paramete ReturnMappingVariables.LameMu_bar = ElasticVariables.LameMu * ( ElasticVariables.traceCG / 3.0 ); //4.-Almansi Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { // e= 0.5*(1-invbT*invb) this->CalculateAlmansiStrain(ElasticVariables.CauchyGreenMatrix,StrainVector); diff --git a/applications/ParticleMechanicsApplication/custom_elements/updated_lagrangian.cpp b/applications/ParticleMechanicsApplication/custom_elements/updated_lagrangian.cpp index 9484f570c94d..301d8d72382c 100644 --- a/applications/ParticleMechanicsApplication/custom_elements/updated_lagrangian.cpp +++ b/applications/ParticleMechanicsApplication/custom_elements/updated_lagrangian.cpp @@ -439,7 +439,7 @@ void UpdatedLagrangian::CalculateElementalSystem( LocalSystemComponents& rLocalS Flags &ConstitutiveLawOptions=Values.GetOptions(); //std::cout<<"in CalculateElementalSystem 5"<CalculateKinematics(Variables,rCurrentProcessInfo); + + //set general variables to constitutivelaw parameters + this->SetGeneralVariables(Variables,Values); + + mConstitutiveLawVector->CalculateMaterialResponse(Values, Variables.StressMeasure); + + //this->SetValue(MP_CAUCHY_STRESS_VECTOR, Variables.StressVector); + //this->SetValue(MP_ALMANSI_STRAIN_VECTOR, Variables.StrainVector); + + //at the first iteration I recover the previous state of stress and strain + //if(rCurrentProcessInfo[NL_ITERATION_NUMBER] == 1) + //{ + //this->SetValue(PREVIOUS_MP_CAUCHY_STRESS_VECTOR, Variables.StressVector); + //this->SetValue(PREVIOUS_MP_ALMANSI_STRAIN_VECTOR, Variables.StrainVector); + //} + //the MP density is updated + double MP_Density = (GetProperties()[DENSITY]) / Variables.detFT; + this->SetValue(MP_DENSITY, MP_Density); + //if(this->Id() == 1786 || this->Id() == 1836) + //{ + //std::cout<<"density "<Id() << GetProperties()[DENSITY]<GetValue(MP_MASS)/this->GetValue(MP_DENSITY); + + //this->SetValue(MP_DENSITY, MP_Density); + this->SetValue(MP_VOLUME, MP_Volume); + + + + + if ( rLocalSystem.CalculationFlags.Is(UpdatedLagrangian::COMPUTE_LHS_MATRIX) ) //calculation of the matrix is required + { + //contributions to stiffness matrix calculated on the reference config this->CalculateAndAddLHS ( rLocalSystem, Variables, MP_Volume ); @@ -1438,19 +1494,8 @@ void UpdatedLagrangian::FinalizeNonLinearIteration( ProcessInfo& rCurrentProcess ////************************************************************************************ ////************************************************************************************ -void UpdatedLagrangian::FinalizeSolutionStep( ProcessInfo& rCurrentProcessInfo ) -{ - KRATOS_TRY - //const unsigned int number_of_nodes = GetGeometry().PointsNumber(); - //const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); - //unsigned int voigtsize = 3; - //array_1d NodalStress; - //if( dimension == 3 ) - //{ - //voigtsize = 6; - //array_1d NodalStress; - //} - //Vector NodalStress = ZeroVector(voigtsize); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); //create and initialize element variables: GeneralVariables Variables; @@ -1462,7 +1507,7 @@ void UpdatedLagrangian::FinalizeSolutionStep( ProcessInfo& rCurrentProcessInfo ) //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); //compute element kinematics B, F, DN_DX ... @@ -2328,13 +2373,13 @@ Matrix& UpdatedLagrangian::MPMShapeFunctionsLocalGradients( Matrix& rResult ) //GeneralVariables Variables; //this->InitializeGeneralVariables(Variables,rCurrentProcessInfo); -////create constitutive law parameters: -//ConstitutiveLaw::Parameters Values(GetGeometry(),GetProperties(),rCurrentProcessInfo); + //ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); + //ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); ////set constitutive law flags: //Flags &ConstitutiveLawOptions=Values.GetOptions(); -//ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); +//ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); //ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); diff --git a/applications/ParticleMechanicsApplication/custom_elements/updated_lagrangian_UP.cpp b/applications/ParticleMechanicsApplication/custom_elements/updated_lagrangian_UP.cpp index 60b6c514780d..3253e8678992 100644 --- a/applications/ParticleMechanicsApplication/custom_elements/updated_lagrangian_UP.cpp +++ b/applications/ParticleMechanicsApplication/custom_elements/updated_lagrangian_UP.cpp @@ -223,7 +223,7 @@ void UpdatedLagrangianUP::InitializeGeneralVariables (GeneralVariables& rVariabl //Flags &ConstitutiveLawOptions=Values.GetOptions(); ////std::cout<<"in CalculateElementalSystem 5"<Id() << GetProperties()[DENSITY]<GetValue(MP_MASS)/this->GetValue(MP_DENSITY); - - this->SetValue(MP_DENSITY, MP_Density); - this->SetValue(MP_VOLUME, MP_Volume); - - - - - if ( rLocalSystem.CalculationFlags.Is(UpdatedLagrangianQuadrilateral::COMPUTE_LHS_MATRIX) ) //calculation of the matrix is required - { - + //create constitutive law parameters: + ConstitutiveLaw::Parameters Values(GetGeometry(),GetProperties(),rCurrentProcessInfo); + + + //set constitutive law flags: + Flags &ConstitutiveLawOptions=Values.GetOptions(); + + //std::cout<<"in CalculateElementalSystem 5"<Id() == 541 || this->Id() == 534 || this->Id() == 538) + //{ + //std::cout<<" in calculate elemental system "<CalculateKinematics(Variables,rCurrentProcessInfo); + + //set general variables to constitutivelaw parameters + this->SetGeneralVariables(Variables,Values); + + mConstitutiveLawVector->CalculateMaterialResponse(Values, Variables.StressMeasure); + + //double TraceStress = 0; + //Matrix I=identity_matrix( dimension ); + //Matrix StressTensor = MathUtils::StressVectorToTensor( Variables.StressVector ); + //for( unsigned int i=0; i::StressVectorToTensor( Variables.IsoStressVector ); + //IsoStressTensor = StressTensor - Pressure * I; + + //double IsoStressNorm = 0; + ////IsoStressNorm = sqrt((IsoStressTensor(0,0)*IsoStressTensor(0,0))+(IsoStressTensor(1,1)*IsoStressTensor(1,1))+(IsoStressTensor(2,2)*IsoStressTensor(2,2))+ + ////(IsoStressTensor(0,1)*IsoStressTensor(0,1))+(IsoStressTensor(0,2)*IsoStressTensor(0,2))+(IsoStressTensor(1,2)*IsoStressTensor(1,2))+ + ////(IsoStressTensor(1,0)*IsoStressTensor(1,0))+(IsoStressTensor(2,0)*IsoStressTensor(2,0))+(IsoStressTensor(2,1)*IsoStressTensor(2,1))); + + //IsoStressNorm = sqrt((IsoStressTensor(0,0)*IsoStressTensor(0,0))+(IsoStressTensor(1,1)*IsoStressTensor(1,1))+ + //(IsoStressTensor(0,1)*IsoStressTensor(0,1))+(IsoStressTensor(1,0)*IsoStressTensor(1,0))); + //Variables.Normal = IsoStressTensor / IsoStressNorm; + //if (IsoStressTensor(0,0) == 0 || IsoStressTensor(1,1) == 0 || IsoStressTensor(0,1) == 0 || IsoStressTensor(1,0)) + //{ + //Variables.Normal = ZeroMatrix(dimension); + //} + + + //std::cout<<"IsoStressTensor "<SetValue(MP_CAUCHY_STRESS_VECTOR, Variables.StressVector); + //std::cout<<"AAAAAAAAAAAAAAAAAAAAAAAAAA"<SetValue(MP_ALMANSI_STRAIN_VECTOR, Variables.StrainVector); + //double EquivalentPlasticStrain = mConstitutiveLawVector->GetValue( PLASTIC_STRAIN, EquivalentPlasticStrain ); + //this->SetValue(MP_EQUIVALENT_PLASTIC_STRAIN, EquivalentPlasticStrain); + //at the first iteration I recover the previous state of stress and strain + if(rCurrentProcessInfo[NL_ITERATION_NUMBER] == 1) + { + this->SetValue(PREVIOUS_MP_CAUCHY_STRESS_VECTOR, Variables.StressVector); + this->SetValue(PREVIOUS_MP_ALMANSI_STRAIN_VECTOR, Variables.StrainVector); + } + //the MP density is updated + double MP_Density = (GetProperties()[DENSITY]) / Variables.detFT; + //if(this->Id() == 1786 || this->Id() == 1836) + //{ + //std::cout<<"density "<Id() << GetProperties()[DENSITY]<GetValue(MP_MASS)/this->GetValue(MP_DENSITY); + + this->SetValue(MP_DENSITY, MP_Density); + this->SetValue(MP_VOLUME, MP_Volume); + + + + + if ( rLocalSystem.CalculationFlags.Is(UpdatedLagrangianQuadrilateral::COMPUTE_LHS_MATRIX) ) //calculation of the matrix is required + { + //contributions to stiffness matrix calculated on the reference config this->CalculateAndAddLHS ( rLocalSystem, Variables, MP_Volume ); @@ -1553,10 +1634,13 @@ void UpdatedLagrangianQuadrilateral::FinalizeSolutionStep( ProcessInfo& rCurrent //create constitutive law parameters: ConstitutiveLaw::Parameters Values(GetGeometry(),GetProperties(),rCurrentProcessInfo); - //set constitutive law flags: - Flags &ConstitutiveLawOptions=Values.GetOptions(); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); + //ConstitutiveLawOptions.Set(ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY); + //compute element kinematics B, F, DN_DX ... + this->CalculateKinematics(Variables, rCurrentProcessInfo); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); //ConstitutiveLawOptions.Set(ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY); //compute element kinematics B, F, DN_DX ... @@ -2610,13 +2694,13 @@ Matrix& UpdatedLagrangianQuadrilateral::MPMShapeFunctionsLocalGradients( Matrix& //GeneralVariables Variables; //this->InitializeGeneralVariables(Variables,rCurrentProcessInfo); -////create constitutive law parameters: -//ConstitutiveLaw::Parameters Values(GetGeometry(),GetProperties(),rCurrentProcessInfo); + //ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); + //ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); ////set constitutive law flags: //Flags &ConstitutiveLawOptions=Values.GetOptions(); -//ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); +//ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); //ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); diff --git a/applications/PfemBaseApplication/CMakeLists.txt b/applications/PfemApplication/CMakeLists.txt similarity index 84% rename from applications/PfemBaseApplication/CMakeLists.txt rename to applications/PfemApplication/CMakeLists.txt index dfdb55098b81..8a2aeddd31eb 100755 --- a/applications/PfemBaseApplication/CMakeLists.txt +++ b/applications/PfemApplication/CMakeLists.txt @@ -1,6 +1,6 @@ set(CMAKE_INCLUDE_CURRENT_DIR ON) -message("**** configuring KratosPfemBaseApplication ****") +message("**** configuring KratosPfemApplication ****") include_directories( ${CMAKE_SOURCE_DIR}/kratos ) @@ -87,10 +87,10 @@ endif(${INCLUDE_TETGEN} MATCHES ON) ## generate variables with the sources -set( KRATOS_PFEM_BASE_APPLICATION_SOURCES - ${CMAKE_CURRENT_SOURCE_DIR}/pfem_base_application.cpp - ${CMAKE_CURRENT_SOURCE_DIR}/pfem_base_application_variables.cpp - ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/pfem_base_python_application.cpp +set( KRATOS_PFEM_APPLICATION_SOURCES + ${CMAKE_CURRENT_SOURCE_DIR}/pfem_application.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/pfem_application_variables.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/pfem_python_application.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_custom_processes_to_python.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_custom_utilities_to_python.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_python/add_custom_modelers_to_python.cpp @@ -112,7 +112,7 @@ set( KRATOS_PFEM_BASE_APPLICATION_SOURCES ############################################################### ## define library Kratos which defines the basic python interface -add_library(KratosPfemBaseApplication SHARED ${KRATOS_PFEM_BASE_APPLICATION_SOURCES}) +add_library(KratosPfemApplication SHARED ${KRATOS_PFEM_APPLICATION_SOURCES}) if(${MSVC}) set(MATLIB "") @@ -133,14 +133,14 @@ else(${INCLUDE_TRIANGLE} MATCHES ON AND ${INCLUDE_TETGEN} MATCHES ON) set(LIBS KratosCore) endif(${INCLUDE_TRIANGLE} MATCHES ON AND ${INCLUDE_TETGEN} MATCHES ON) -target_link_libraries(KratosPfemBaseApplication ${LIBS}) -##target_link_libraries(KratosPfemBaseApplication KratosCore triangle tetgen msuite) -##target_link_libraries(KratosPfemBaseApplication KratosCore triangle tetgen msuite tetMeshOpt) +target_link_libraries(KratosPfemApplication ${LIBS}) +##target_link_libraries(KratosPfemApplication KratosCore triangle tetgen msuite) +##target_link_libraries(KratosPfemApplication KratosCore triangle tetgen msuite tetMeshOpt) -set_target_properties(KratosPfemBaseApplication PROPERTIES PREFIX "") -set_target_properties(KratosPfemBaseApplication PROPERTIES COMPILE_DEFINITIONS "PFEM_BASE_APPLICATION=EXPORT,API") +set_target_properties(KratosPfemApplication PROPERTIES PREFIX "") +set_target_properties(KratosPfemApplication PROPERTIES COMPILE_DEFINITIONS "PFEM_APPLICATION=EXPORT,API") -install(TARGETS KratosPfemBaseApplication DESTINATION libs ) +install(TARGETS KratosPfemApplication DESTINATION libs ) # get_property(inc_dirs DIRECTORY PROPERTY INCLUDE_DIRECTORIES) @@ -148,12 +148,12 @@ install(TARGETS KratosPfemBaseApplication DESTINATION libs ) # changing the .dll suffix to .pyd if(${CMAKE_SYSTEM_NAME} MATCHES "Windows") - set_target_properties(KratosPfemBaseApplication PROPERTIES SUFFIX .pyd) + set_target_properties(KratosPfemApplication PROPERTIES SUFFIX .pyd) endif(${CMAKE_SYSTEM_NAME} MATCHES "Windows") # changing the .dylib suffix to .so if(${CMAKE_SYSTEM_NAME} MATCHES "Darwin") - set_target_properties(KratosPfemBaseApplication PROPERTIES SUFFIX .so) + set_target_properties(KratosPfemApplication PROPERTIES SUFFIX .so) endif(${CMAKE_SYSTEM_NAME} MATCHES "Darwin") if(${INSTALL_PYTHON_FILES} MATCHES ON) @@ -162,7 +162,7 @@ if(${INSTALL_PYTHON_FILES} MATCHES ON) endif(${INSTALL_PYTHON_FILES} MATCHES ON) # get_property(inc_dirs DIRECTORY PROPERTY INCLUDE_DIRECTORIES) -# message("PfemBaseApplication subdir inc_dirs = ${inc_dirs}") +# message("PfemApplication subdir inc_dirs = ${inc_dirs}") # Add to the KratosMultiphisics Python module -install(FILES "${CMAKE_CURRENT_SOURCE_DIR}/PfemBaseApplication.py" DESTINATION KratosMultiphysics ) +install(FILES "${CMAKE_CURRENT_SOURCE_DIR}/PfemApplication.py" DESTINATION KratosMultiphysics ) diff --git a/applications/PFEMapplication/PFEMApplication.py b/applications/PfemApplication/PfemApplication.py old mode 100644 new mode 100755 similarity index 73% rename from applications/PFEMapplication/PFEMApplication.py rename to applications/PfemApplication/PfemApplication.py index 7eec9612aac9..dd7f8bd4cbde --- a/applications/PFEMapplication/PFEMApplication.py +++ b/applications/PfemApplication/PfemApplication.py @@ -1,8 +1,8 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -from KratosPFEMApplication import * -application = KratosPFEMApplication() -application_name = "KratosPFEMApplication" -application_folder = "PFEMapplication" +from KratosPfemApplication import * +application = KratosPfemApplication() +application_name = "KratosPfemApplication " +application_folder = "PfemApplication" # The following lines are common for all applications from . import application_importer diff --git a/applications/PfemBaseApplication/custom_bounding/spatial_bounding_box.hpp b/applications/PfemApplication/custom_bounding/spatial_bounding_box.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_bounding/spatial_bounding_box.hpp rename to applications/PfemApplication/custom_bounding/spatial_bounding_box.hpp index 46fbd606bb74..cde26018cb6b 100755 --- a/applications/PfemBaseApplication/custom_bounding/spatial_bounding_box.hpp +++ b/applications/PfemApplication/custom_bounding/spatial_bounding_box.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: July 2016 $ @@ -49,7 +49,7 @@ namespace Kratos /** Detail class definition. */ -class KRATOS_API(PFEM_BASE_APPLICATION) SpatialBoundingBox +class KRATOS_API(PFEM_APPLICATION) SpatialBoundingBox { public: diff --git a/applications/PfemBaseApplication/custom_conditions/composite_condition.cpp b/applications/PfemApplication/custom_conditions/composite_condition.cpp similarity index 99% rename from applications/PfemBaseApplication/custom_conditions/composite_condition.cpp rename to applications/PfemApplication/custom_conditions/composite_condition.cpp index 2eb0010c2af5..a9f18e75ae4b 100644 --- a/applications/PfemBaseApplication/custom_conditions/composite_condition.cpp +++ b/applications/PfemApplication/custom_conditions/composite_condition.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -14,7 +14,7 @@ // Project includes #include "custom_conditions/composite_condition.hpp" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos { diff --git a/applications/PfemBaseApplication/custom_conditions/composite_condition.hpp b/applications/PfemApplication/custom_conditions/composite_condition.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_conditions/composite_condition.hpp rename to applications/PfemApplication/custom_conditions/composite_condition.hpp index 4b87936576ce..e80ae99ede7e 100644 --- a/applications/PfemBaseApplication/custom_conditions/composite_condition.hpp +++ b/applications/PfemApplication/custom_conditions/composite_condition.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -44,7 +44,7 @@ namespace Kratos * This works for arbitrary geometries in 2D and 3D */ -class KRATOS_API(PFEM_BASE_APPLICATION) CompositeCondition +class KRATOS_API(PFEM_APPLICATION) CompositeCondition : public Condition { public: diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/CMakeLists.txt b/applications/PfemApplication/custom_external_libraries/msuite/CMakeLists.txt similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/CMakeLists.txt rename to applications/PfemApplication/custom_external_libraries/msuite/CMakeLists.txt diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/Jamfile b/applications/PfemApplication/custom_external_libraries/msuite/Jamfile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/Jamfile rename to applications/PfemApplication/custom_external_libraries/msuite/Jamfile diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/Makefile b/applications/PfemApplication/custom_external_libraries/msuite/src/Makefile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/Makefile rename to applications/PfemApplication/custom_external_libraries/msuite/src/Makefile diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/alpha.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/alpha.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/alpha.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/alpha.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/custom.h b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/custom.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/custom.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/custom.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/edt.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/edt.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/edt.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/edt.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/esfera.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/esfera.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/esfera.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/esfera.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/esfera.h b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/esfera.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/esfera.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/esfera.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/hydir.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/hydir.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/hydir.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/hydir.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/s_squeeze.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/s_squeeze.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/s_squeeze.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/s_squeeze.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/slivers.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/slivers.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/slivers.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/slivers.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/vadebug.h b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/vadebug.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/vadebug.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/vadebug.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/vor_out.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/vor_out.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/vor_out.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/vor_out.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/voronoi.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/voronoi.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/voronoi.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/voronoi.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/voronoi.h b/applications/PfemApplication/custom_external_libraries/msuite/src/edt/voronoi.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/edt/voronoi.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/edt/voronoi.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/generate_makefile.sh b/applications/PfemApplication/custom_external_libraries/msuite/src/generate_makefile.sh similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/generate_makefile.sh rename to applications/PfemApplication/custom_external_libraries/msuite/src/generate_makefile.sh diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/corte.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/corte.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/corte.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/corte.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/delaunay.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/delaunay.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/delaunay.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/delaunay.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/elemento.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/elemento.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/elemento.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/elemento.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/elemento.h b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/elemento.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/elemento.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/elemento.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/fforma.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/fforma.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/fforma.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/fforma.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/grabamalla.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/grabamalla.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/grabamalla.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/grabamalla.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/leemalla.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/leemalla.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/leemalla.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/leemalla.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/malla.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/malla.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/malla.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/malla.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/malla.h b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/malla.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/malla.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/malla.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/mensajes.h b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/mensajes.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/mensajes.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/mensajes.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/meshelm.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/meshelm.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/meshelm.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/meshelm.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/no_remalla.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/no_remalla.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/no_remalla.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/no_remalla.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/nodo.h b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/nodo.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/nodo.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/nodo.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/orienta.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/orienta.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/orienta.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/orienta.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/refina.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/refina.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/refina.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/refina.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/smooth.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/smooth.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/smooth.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/smooth.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/surface.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/surface.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/surface.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/surface.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/vecinos_y_frontera.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/malla/vecinos_y_frontera.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/malla/vecinos_y_frontera.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/malla/vecinos_y_frontera.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/msuite_cli b/applications/PfemApplication/custom_external_libraries/msuite/src/msuite_cli similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/msuite_cli rename to applications/PfemApplication/custom_external_libraries/msuite/src/msuite_cli diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/array1.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/array1.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/array1.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/array1.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/case.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/util/case.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/case.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/case.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/case.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/case.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/case.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/case.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/color.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/color.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/color.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/color.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/color.h.pld b/applications/PfemApplication/custom_external_libraries/msuite/src/util/color.h.pld similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/color.h.pld rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/color.h.pld diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/cone.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/util/cone.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/cone.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/cone.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/cone.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/cone.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/cone.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/cone.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/filename.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/util/filename.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/filename.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/filename.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/filename.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/filename.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/filename.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/filename.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/flags.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/flags.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/flags.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/flags.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/octree.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/util/octree.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/octree.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/octree.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/octree.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/octree.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/octree.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/octree.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/pline.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/util/pline.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/pline.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/pline.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/pline.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/pline.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/pline.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/pline.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/punto.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/util/punto.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/punto.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/punto.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/punto.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/punto.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/punto.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/punto.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/tiempo.cpp b/applications/PfemApplication/custom_external_libraries/msuite/src/util/tiempo.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/tiempo.cpp rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/tiempo.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/tiempo.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/tiempo.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/tiempo.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/tiempo.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/utiles.h b/applications/PfemApplication/custom_external_libraries/msuite/src/util/utiles.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/msuite/src/util/utiles.h rename to applications/PfemApplication/custom_external_libraries/msuite/src/util/utiles.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/CMakeLists.txt b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/CMakeLists.txt similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/CMakeLists.txt rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/CMakeLists.txt diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/Math3D.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/Math3D.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/Math3D.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/Math3D.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/Math3D.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/Math3D.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/Math3D.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/Math3D.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/MeshOptimizer.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/MeshOptimizer.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/MeshOptimizer.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/MeshOptimizer.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_MeshLoaders.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_MeshSmooth.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ParallelFunctions.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ProcessTime.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_Render.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_Render.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_Render.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_Render.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_ShowMetrics.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_TetGenInterface.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_TetraFunctions.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_Types.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_Types.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_Types.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_Types.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_Types.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_Types.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_Types.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_Types.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_colorScale.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_colorScale.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_colorScale.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_colorScale.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_colorScale.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_colorScale.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_colorScale.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_colorScale.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_delphiClasses.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_elementCluster.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_elementCluster.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_elementCluster.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_elementCluster.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_elementCluster.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_elementCluster.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_elementCluster.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_elementCluster.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_qualityMetrics.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_tools.cpp b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_tools.cpp similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_tools.cpp rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_tools.cpp diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_tools.h b/applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_tools.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetMeshOpt/u_tools.h rename to applications/PfemApplication/custom_external_libraries/tetMeshOpt/u_tools.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/Jamfile b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/Jamfile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/Jamfile rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/Jamfile diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/LICENSE b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/LICENSE similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/LICENSE rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/LICENSE diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/README b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/README similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/README rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/README diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/example.poly b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/example.poly similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/example.poly rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/example.poly diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/makefile b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/makefile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/makefile rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/makefile diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/predicates.cxx b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/predicates.cxx similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/predicates.cxx rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/predicates.cxx diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen-manual.pdf b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen-manual.pdf similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen-manual.pdf rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen-manual.pdf diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen.cxx b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen.cxx similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen.cxx rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen.cxx diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen.h b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen.h rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.0/tetgen.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/Jamfile b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/Jamfile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/Jamfile rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/Jamfile diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/LICENSE b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/LICENSE similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/LICENSE rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/LICENSE diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/README b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/README similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/README rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/README diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/example.poly b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/example.poly similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/example.poly rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/example.poly diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/makefile b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/makefile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/makefile rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/makefile diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/predicates.cxx b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/predicates.cxx similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/predicates.cxx rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/predicates.cxx diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen.cxx b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen.cxx similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen.cxx rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen.cxx diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen.h b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen.h rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.2/tetgen.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/CMakeLists.txt b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/CMakeLists.txt similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/CMakeLists.txt rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/CMakeLists.txt diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/Jamfile b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/Jamfile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/Jamfile rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/Jamfile diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/LICENSE b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/LICENSE similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/LICENSE rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/LICENSE diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/README b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/README similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/README rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/README diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/example.poly b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/example.poly similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/example.poly rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/example.poly diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/makefile b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/makefile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/makefile rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/makefile diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/predicates.cxx b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/predicates.cxx similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/predicates.cxx rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/predicates.cxx diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/predicates.plist b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/predicates.plist similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/predicates.plist rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/predicates.plist diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.cxx b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.cxx similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.cxx rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.cxx diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.h b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.h rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.4.3/tetgen.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/CMakeLists.txt b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/CMakeLists.txt similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/CMakeLists.txt rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/CMakeLists.txt diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/LICENSE b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/LICENSE similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/LICENSE rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/LICENSE diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/README b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/README similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/README rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/README diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/example.poly b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/example.poly similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/example.poly rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/example.poly diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/makefile b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/makefile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/makefile rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/makefile diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/predicates.cxx b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/predicates.cxx similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/predicates.cxx rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/predicates.cxx diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/tetgen.cxx b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/tetgen.cxx similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/tetgen.cxx rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/tetgen.cxx diff --git a/applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/tetgen.h b/applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/tetgen.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/tetgen/tetgen1.5.0/tetgen.h rename to applications/PfemApplication/custom_external_libraries/tetgen/tetgen1.5.0/tetgen.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/triangle/A.poly b/applications/PfemApplication/custom_external_libraries/triangle/A.poly similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/triangle/A.poly rename to applications/PfemApplication/custom_external_libraries/triangle/A.poly diff --git a/applications/PfemBaseApplication/custom_external_libraries/triangle/CMakeLists.txt b/applications/PfemApplication/custom_external_libraries/triangle/CMakeLists.txt similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/triangle/CMakeLists.txt rename to applications/PfemApplication/custom_external_libraries/triangle/CMakeLists.txt diff --git a/applications/PfemBaseApplication/custom_external_libraries/triangle/Jamfile b/applications/PfemApplication/custom_external_libraries/triangle/Jamfile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/triangle/Jamfile rename to applications/PfemApplication/custom_external_libraries/triangle/Jamfile diff --git a/applications/PfemBaseApplication/custom_external_libraries/triangle/README b/applications/PfemApplication/custom_external_libraries/triangle/README similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/triangle/README rename to applications/PfemApplication/custom_external_libraries/triangle/README diff --git a/applications/PfemBaseApplication/custom_external_libraries/triangle/makefile b/applications/PfemApplication/custom_external_libraries/triangle/makefile similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/triangle/makefile rename to applications/PfemApplication/custom_external_libraries/triangle/makefile diff --git a/applications/PfemBaseApplication/custom_external_libraries/triangle/showme.c b/applications/PfemApplication/custom_external_libraries/triangle/showme.c similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/triangle/showme.c rename to applications/PfemApplication/custom_external_libraries/triangle/showme.c diff --git a/applications/PfemBaseApplication/custom_external_libraries/triangle/triangle.c b/applications/PfemApplication/custom_external_libraries/triangle/triangle.c similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/triangle/triangle.c rename to applications/PfemApplication/custom_external_libraries/triangle/triangle.c diff --git a/applications/PfemBaseApplication/custom_external_libraries/triangle/triangle.h b/applications/PfemApplication/custom_external_libraries/triangle/triangle.h similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/triangle/triangle.h rename to applications/PfemApplication/custom_external_libraries/triangle/triangle.h diff --git a/applications/PfemBaseApplication/custom_external_libraries/triangle/tricall.c b/applications/PfemApplication/custom_external_libraries/triangle/tricall.c similarity index 100% rename from applications/PfemBaseApplication/custom_external_libraries/triangle/tricall.c rename to applications/PfemApplication/custom_external_libraries/triangle/tricall.c diff --git a/applications/PfemBaseApplication/custom_modelers/laplacian_smoothing.hpp b/applications/PfemApplication/custom_modelers/laplacian_smoothing.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_modelers/laplacian_smoothing.hpp rename to applications/PfemApplication/custom_modelers/laplacian_smoothing.hpp index 42a029ba3b7a..1bae846febcc 100755 --- a/applications/PfemBaseApplication/custom_modelers/laplacian_smoothing.hpp +++ b/applications/PfemApplication/custom_modelers/laplacian_smoothing.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -25,7 +25,7 @@ #include "spatial_containers/spatial_containers.h" #include "custom_utilities/modeler_utilities.hpp" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" #ifdef SINGLE #define REAL float diff --git a/applications/PfemBaseApplication/custom_modelers/mesh_modeler.cpp b/applications/PfemApplication/custom_modelers/mesh_modeler.cpp similarity index 99% rename from applications/PfemBaseApplication/custom_modelers/mesh_modeler.cpp rename to applications/PfemApplication/custom_modelers/mesh_modeler.cpp index 655af8e78903..a593cfea6711 100644 --- a/applications/PfemBaseApplication/custom_modelers/mesh_modeler.cpp +++ b/applications/PfemApplication/custom_modelers/mesh_modeler.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -15,7 +15,7 @@ #include "custom_modelers/laplacian_smoothing.hpp" #include "custom_modelers/mesh_modeler.hpp" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos { diff --git a/applications/PfemBaseApplication/custom_modelers/mesh_modeler.hpp b/applications/PfemApplication/custom_modelers/mesh_modeler.hpp similarity index 98% rename from applications/PfemBaseApplication/custom_modelers/mesh_modeler.hpp rename to applications/PfemApplication/custom_modelers/mesh_modeler.hpp index 277e2f69e9b2..6004e50e1a23 100644 --- a/applications/PfemBaseApplication/custom_modelers/mesh_modeler.hpp +++ b/applications/PfemApplication/custom_modelers/mesh_modeler.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -62,7 +62,7 @@ namespace Kratos /// Short class definition. /** Detail class definition. */ -class KRATOS_API(PFEM_BASE_APPLICATION) MeshModeler +class KRATOS_API(PFEM_APPLICATION) MeshModeler { public: diff --git a/applications/PfemBaseApplication/custom_modelers/tetrahedral_mesh_3D_modeler.cpp b/applications/PfemApplication/custom_modelers/tetrahedral_mesh_3D_modeler.cpp similarity index 98% rename from applications/PfemBaseApplication/custom_modelers/tetrahedral_mesh_3D_modeler.cpp rename to applications/PfemApplication/custom_modelers/tetrahedral_mesh_3D_modeler.cpp index 776c11ebd1a5..8a7830a2f30e 100644 --- a/applications/PfemBaseApplication/custom_modelers/tetrahedral_mesh_3D_modeler.cpp +++ b/applications/PfemApplication/custom_modelers/tetrahedral_mesh_3D_modeler.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -16,7 +16,7 @@ #include "custom_modelers/tetrahedral_mesh_3D_modeler.hpp" #include "geometries/tetrahedra_3d_4.h" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos @@ -33,7 +33,7 @@ namespace Kratos unsigned int& MeshId = rMeshingVariables.MeshId; - this->StartEcho(rModelPart,"PFEM Base Remesh",MeshId); + this->StartEcho(rModelPart,"PFEM Remesh",MeshId); //********************************************************************* @@ -103,7 +103,7 @@ namespace Kratos DeleteOutContainer(rMeshingVariables.OutMesh,out); - this->EndEcho(rModelPart,"PFEM Base Remesh",MeshId); + this->EndEcho(rModelPart,"PFEM Remesh",MeshId); KRATOS_CATCH( "" ) diff --git a/applications/PfemBaseApplication/custom_modelers/tetrahedral_mesh_3D_modeler.hpp b/applications/PfemApplication/custom_modelers/tetrahedral_mesh_3D_modeler.hpp similarity index 98% rename from applications/PfemBaseApplication/custom_modelers/tetrahedral_mesh_3D_modeler.hpp rename to applications/PfemApplication/custom_modelers/tetrahedral_mesh_3D_modeler.hpp index 6ffd0c2b0bf4..6915c3af8fac 100644 --- a/applications/PfemBaseApplication/custom_modelers/tetrahedral_mesh_3D_modeler.hpp +++ b/applications/PfemApplication/custom_modelers/tetrahedral_mesh_3D_modeler.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -50,7 +50,7 @@ namespace Kratos /// Short class definition. /** Detail class definition. */ -class KRATOS_API(PFEM_BASE_APPLICATION) TetrahedralMesh3DModeler +class KRATOS_API(PFEM_APPLICATION) TetrahedralMesh3DModeler : public MeshModeler { protected: diff --git a/applications/PfemBaseApplication/custom_modelers/triangular_mesh_2D_modeler.cpp b/applications/PfemApplication/custom_modelers/triangular_mesh_2D_modeler.cpp similarity index 98% rename from applications/PfemBaseApplication/custom_modelers/triangular_mesh_2D_modeler.cpp rename to applications/PfemApplication/custom_modelers/triangular_mesh_2D_modeler.cpp index d39449d83e53..de4285107b71 100644 --- a/applications/PfemBaseApplication/custom_modelers/triangular_mesh_2D_modeler.cpp +++ b/applications/PfemApplication/custom_modelers/triangular_mesh_2D_modeler.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -15,7 +15,7 @@ #include "custom_modelers/laplacian_smoothing.hpp" #include "custom_modelers/triangular_mesh_2D_modeler.hpp" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos @@ -32,7 +32,7 @@ namespace Kratos unsigned int& MeshId = rMeshingVariables.MeshId; - this->StartEcho(rModelPart,"PFEM Base Remesh",MeshId); + this->StartEcho(rModelPart,"PFEM Remesh",MeshId); //********************************************************************* @@ -104,7 +104,7 @@ namespace Kratos DeleteOutContainer(rMeshingVariables.OutMesh,out); - this->EndEcho(rModelPart,"PFEM Base Remesh",MeshId); + this->EndEcho(rModelPart,"PFEM Remesh",MeshId); KRATOS_CATCH( "" ) diff --git a/applications/PfemBaseApplication/custom_modelers/triangular_mesh_2D_modeler.hpp b/applications/PfemApplication/custom_modelers/triangular_mesh_2D_modeler.hpp similarity index 98% rename from applications/PfemBaseApplication/custom_modelers/triangular_mesh_2D_modeler.hpp rename to applications/PfemApplication/custom_modelers/triangular_mesh_2D_modeler.hpp index 03bcd78a97e1..2ebf1f0221e9 100644 --- a/applications/PfemBaseApplication/custom_modelers/triangular_mesh_2D_modeler.hpp +++ b/applications/PfemApplication/custom_modelers/triangular_mesh_2D_modeler.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -76,7 +76,7 @@ namespace Kratos /// Short class definition. /** Detail class definition. */ -class KRATOS_API(PFEM_BASE_APPLICATION) TriangularMesh2DModeler +class KRATOS_API(PFEM_APPLICATION) TriangularMesh2DModeler : public MeshModeler { protected: diff --git a/applications/PfemBaseApplication/custom_processes/build_mesh_boundary_process.hpp b/applications/PfemApplication/custom_processes/build_mesh_boundary_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/build_mesh_boundary_process.hpp rename to applications/PfemApplication/custom_processes/build_mesh_boundary_process.hpp index a1d7fec2d5e1..00990b2c557c 100644 --- a/applications/PfemBaseApplication/custom_processes/build_mesh_boundary_process.hpp +++ b/applications/PfemApplication/custom_processes/build_mesh_boundary_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/build_mesh_elements_process.hpp b/applications/PfemApplication/custom_processes/build_mesh_elements_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/build_mesh_elements_process.hpp rename to applications/PfemApplication/custom_processes/build_mesh_elements_process.hpp index a7d14fce39d4..df92f70cbe46 100644 --- a/applications/PfemBaseApplication/custom_processes/build_mesh_elements_process.hpp +++ b/applications/PfemApplication/custom_processes/build_mesh_elements_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/build_model_part_boundary_process.hpp b/applications/PfemApplication/custom_processes/build_model_part_boundary_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/build_model_part_boundary_process.hpp rename to applications/PfemApplication/custom_processes/build_model_part_boundary_process.hpp index fe8c78e70cb5..2784a943aa9f 100644 --- a/applications/PfemBaseApplication/custom_processes/build_model_part_boundary_process.hpp +++ b/applications/PfemApplication/custom_processes/build_model_part_boundary_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -36,7 +36,7 @@ #include "custom_utilities/boundary_normals_calculation_utilities.hpp" #include "custom_utilities/modeler_utilities.hpp" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" ///VARIABLES used: //Data: MASTER_ELEMENTS(set), MASTER_NODES(set), NEIGHBOUR_ELEMENTS diff --git a/applications/PfemBaseApplication/custom_processes/constant_rotation_process.h b/applications/PfemApplication/custom_processes/constant_rotation_process.h similarity index 100% rename from applications/PfemBaseApplication/custom_processes/constant_rotation_process.h rename to applications/PfemApplication/custom_processes/constant_rotation_process.h diff --git a/applications/PfemBaseApplication/custom_processes/elemental_neighbours_search_process.hpp b/applications/PfemApplication/custom_processes/elemental_neighbours_search_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/elemental_neighbours_search_process.hpp rename to applications/PfemApplication/custom_processes/elemental_neighbours_search_process.hpp index b3c022d66bf1..5974f0640934 100755 --- a/applications/PfemBaseApplication/custom_processes/elemental_neighbours_search_process.hpp +++ b/applications/PfemApplication/custom_processes/elemental_neighbours_search_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -27,7 +27,7 @@ #include "includes/node.h" #include "includes/element.h" #include "includes/model_part.h" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" ///VARIABLES used: diff --git a/applications/PfemBaseApplication/custom_processes/generate_new_nodes_process.hpp b/applications/PfemApplication/custom_processes/generate_new_nodes_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/generate_new_nodes_process.hpp rename to applications/PfemApplication/custom_processes/generate_new_nodes_process.hpp index 4839121b4890..67f840c2ec33 100644 --- a/applications/PfemBaseApplication/custom_processes/generate_new_nodes_process.hpp +++ b/applications/PfemApplication/custom_processes/generate_new_nodes_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/model_start_end_meshing_process.hpp b/applications/PfemApplication/custom_processes/model_start_end_meshing_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/model_start_end_meshing_process.hpp rename to applications/PfemApplication/custom_processes/model_start_end_meshing_process.hpp index b0a92aa67e2a..a8916b0a35d5 100644 --- a/applications/PfemBaseApplication/custom_processes/model_start_end_meshing_process.hpp +++ b/applications/PfemApplication/custom_processes/model_start_end_meshing_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -20,7 +20,7 @@ #include "custom_processes/nodal_neighbours_search_process.hpp" #include "custom_processes/build_model_part_boundary_process.hpp" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" ///VARIABLES used: //Data: diff --git a/applications/PfemBaseApplication/custom_processes/model_volume_calculation_process.hpp b/applications/PfemApplication/custom_processes/model_volume_calculation_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/model_volume_calculation_process.hpp rename to applications/PfemApplication/custom_processes/model_volume_calculation_process.hpp index 29ef7d72b3b9..f7730e65b11c 100644 --- a/applications/PfemBaseApplication/custom_processes/model_volume_calculation_process.hpp +++ b/applications/PfemApplication/custom_processes/model_volume_calculation_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/nodal_neighbours_search_process.hpp b/applications/PfemApplication/custom_processes/nodal_neighbours_search_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/nodal_neighbours_search_process.hpp rename to applications/PfemApplication/custom_processes/nodal_neighbours_search_process.hpp index e26533dd4614..73b0b1f61301 100755 --- a/applications/PfemBaseApplication/custom_processes/nodal_neighbours_search_process.hpp +++ b/applications/PfemApplication/custom_processes/nodal_neighbours_search_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/print_output_mesh_process.hpp b/applications/PfemApplication/custom_processes/print_output_mesh_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/print_output_mesh_process.hpp rename to applications/PfemApplication/custom_processes/print_output_mesh_process.hpp index 00427b4245e8..c392f1a0307d 100644 --- a/applications/PfemBaseApplication/custom_processes/print_output_mesh_process.hpp +++ b/applications/PfemApplication/custom_processes/print_output_mesh_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/refine_mesh_boundary_process.hpp b/applications/PfemApplication/custom_processes/refine_mesh_boundary_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/refine_mesh_boundary_process.hpp rename to applications/PfemApplication/custom_processes/refine_mesh_boundary_process.hpp index 51a48290fb6b..ee0c6b591580 100644 --- a/applications/PfemBaseApplication/custom_processes/refine_mesh_boundary_process.hpp +++ b/applications/PfemApplication/custom_processes/refine_mesh_boundary_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/refine_mesh_elements_in_edges_process.hpp b/applications/PfemApplication/custom_processes/refine_mesh_elements_in_edges_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/refine_mesh_elements_in_edges_process.hpp rename to applications/PfemApplication/custom_processes/refine_mesh_elements_in_edges_process.hpp index de8add98d1a5..67ced3f53bdf 100644 --- a/applications/PfemBaseApplication/custom_processes/refine_mesh_elements_in_edges_process.hpp +++ b/applications/PfemApplication/custom_processes/refine_mesh_elements_in_edges_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/refine_mesh_elements_on_size_process.hpp b/applications/PfemApplication/custom_processes/refine_mesh_elements_on_size_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/refine_mesh_elements_on_size_process.hpp rename to applications/PfemApplication/custom_processes/refine_mesh_elements_on_size_process.hpp index 6c7ea0e6db74..95c8fc66fe81 100644 --- a/applications/PfemBaseApplication/custom_processes/refine_mesh_elements_on_size_process.hpp +++ b/applications/PfemApplication/custom_processes/refine_mesh_elements_on_size_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/refine_mesh_elements_on_threshold_process.hpp b/applications/PfemApplication/custom_processes/refine_mesh_elements_on_threshold_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/refine_mesh_elements_on_threshold_process.hpp rename to applications/PfemApplication/custom_processes/refine_mesh_elements_on_threshold_process.hpp index 29eca7558a77..b6b84ee709e7 100644 --- a/applications/PfemBaseApplication/custom_processes/refine_mesh_elements_on_threshold_process.hpp +++ b/applications/PfemApplication/custom_processes/refine_mesh_elements_on_threshold_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/remove_mesh_nodes_process.hpp b/applications/PfemApplication/custom_processes/remove_mesh_nodes_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/remove_mesh_nodes_process.hpp rename to applications/PfemApplication/custom_processes/remove_mesh_nodes_process.hpp index 4e8889bcf075..905bbab4fc81 100644 --- a/applications/PfemBaseApplication/custom_processes/remove_mesh_nodes_process.hpp +++ b/applications/PfemApplication/custom_processes/remove_mesh_nodes_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_processes/select_mesh_elements_process.hpp b/applications/PfemApplication/custom_processes/select_mesh_elements_process.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_processes/select_mesh_elements_process.hpp rename to applications/PfemApplication/custom_processes/select_mesh_elements_process.hpp index b1862029dfe8..cbd60f615b07 100644 --- a/applications/PfemBaseApplication/custom_processes/select_mesh_elements_process.hpp +++ b/applications/PfemApplication/custom_processes/select_mesh_elements_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_bounding_to_python.cpp b/applications/PfemApplication/custom_python/add_custom_bounding_to_python.cpp similarity index 97% rename from applications/PfemBaseApplication/custom_python/add_custom_bounding_to_python.cpp rename to applications/PfemApplication/custom_python/add_custom_bounding_to_python.cpp index 20dc14d7719d..d3611381013f 100644 --- a/applications/PfemBaseApplication/custom_python/add_custom_bounding_to_python.cpp +++ b/applications/PfemApplication/custom_python/add_custom_bounding_to_python.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_bounding_to_python.h b/applications/PfemApplication/custom_python/add_custom_bounding_to_python.h similarity index 92% rename from applications/PfemBaseApplication/custom_python/add_custom_bounding_to_python.h rename to applications/PfemApplication/custom_python/add_custom_bounding_to_python.h index a15f86362ce1..2b3ccf0662e9 100644 --- a/applications/PfemBaseApplication/custom_python/add_custom_bounding_to_python.h +++ b/applications/PfemApplication/custom_python/add_custom_bounding_to_python.h @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_conditions_to_python.cpp b/applications/PfemApplication/custom_python/add_custom_conditions_to_python.cpp similarity index 96% rename from applications/PfemBaseApplication/custom_python/add_custom_conditions_to_python.cpp rename to applications/PfemApplication/custom_python/add_custom_conditions_to_python.cpp index ff83e627f94d..9cdb69610172 100755 --- a/applications/PfemBaseApplication/custom_python/add_custom_conditions_to_python.cpp +++ b/applications/PfemApplication/custom_python/add_custom_conditions_to_python.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_conditions_to_python.h b/applications/PfemApplication/custom_python/add_custom_conditions_to_python.h similarity index 92% rename from applications/PfemBaseApplication/custom_python/add_custom_conditions_to_python.h rename to applications/PfemApplication/custom_python/add_custom_conditions_to_python.h index 0dbd7ae02f54..02fc08830ca6 100755 --- a/applications/PfemBaseApplication/custom_python/add_custom_conditions_to_python.h +++ b/applications/PfemApplication/custom_python/add_custom_conditions_to_python.h @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_modelers_to_python.cpp b/applications/PfemApplication/custom_python/add_custom_modelers_to_python.cpp similarity index 97% rename from applications/PfemBaseApplication/custom_python/add_custom_modelers_to_python.cpp rename to applications/PfemApplication/custom_python/add_custom_modelers_to_python.cpp index 6a3a68e8f4ed..9674dc02dd46 100644 --- a/applications/PfemBaseApplication/custom_python/add_custom_modelers_to_python.cpp +++ b/applications/PfemApplication/custom_python/add_custom_modelers_to_python.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_modelers_to_python.h b/applications/PfemApplication/custom_python/add_custom_modelers_to_python.h similarity index 92% rename from applications/PfemBaseApplication/custom_python/add_custom_modelers_to_python.h rename to applications/PfemApplication/custom_python/add_custom_modelers_to_python.h index 04400f6fc9e8..4f92bc0aac77 100644 --- a/applications/PfemBaseApplication/custom_python/add_custom_modelers_to_python.h +++ b/applications/PfemApplication/custom_python/add_custom_modelers_to_python.h @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_processes_to_python.cpp b/applications/PfemApplication/custom_python/add_custom_processes_to_python.cpp similarity index 99% rename from applications/PfemBaseApplication/custom_python/add_custom_processes_to_python.cpp rename to applications/PfemApplication/custom_python/add_custom_processes_to_python.cpp index aaaef25eb70f..c7b2f43d0d78 100644 --- a/applications/PfemBaseApplication/custom_python/add_custom_processes_to_python.cpp +++ b/applications/PfemApplication/custom_python/add_custom_processes_to_python.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_processes_to_python.h b/applications/PfemApplication/custom_python/add_custom_processes_to_python.h similarity index 92% rename from applications/PfemBaseApplication/custom_python/add_custom_processes_to_python.h rename to applications/PfemApplication/custom_python/add_custom_processes_to_python.h index 07932c7f91ce..e81c29e84e76 100644 --- a/applications/PfemBaseApplication/custom_python/add_custom_processes_to_python.h +++ b/applications/PfemApplication/custom_python/add_custom_processes_to_python.h @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_utilities_to_python.cpp b/applications/PfemApplication/custom_python/add_custom_utilities_to_python.cpp similarity index 99% rename from applications/PfemBaseApplication/custom_python/add_custom_utilities_to_python.cpp rename to applications/PfemApplication/custom_python/add_custom_utilities_to_python.cpp index 8be8e8086a7a..ee00c00d152d 100755 --- a/applications/PfemBaseApplication/custom_python/add_custom_utilities_to_python.cpp +++ b/applications/PfemApplication/custom_python/add_custom_utilities_to_python.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/add_custom_utilities_to_python.h b/applications/PfemApplication/custom_python/add_custom_utilities_to_python.h similarity index 92% rename from applications/PfemBaseApplication/custom_python/add_custom_utilities_to_python.h rename to applications/PfemApplication/custom_python/add_custom_utilities_to_python.h index a584f350eefc..dc6204d15c23 100755 --- a/applications/PfemBaseApplication/custom_python/add_custom_utilities_to_python.h +++ b/applications/PfemApplication/custom_python/add_custom_utilities_to_python.h @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_python/pfem_base_python_application.cpp b/applications/PfemApplication/custom_python/pfem_python_application.cpp similarity index 85% rename from applications/PfemBaseApplication/custom_python/pfem_base_python_application.cpp rename to applications/PfemApplication/custom_python/pfem_python_application.cpp index ea53e15a8e48..487053b408f5 100755 --- a/applications/PfemBaseApplication/custom_python/pfem_base_python_application.cpp +++ b/applications/PfemApplication/custom_python/pfem_python_application.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -20,7 +20,7 @@ #include "custom_python/add_custom_modelers_to_python.h" #include "custom_python/add_custom_bounding_to_python.h" -#include "pfem_base_application.h" +#include "pfem_application.h" namespace Kratos { @@ -30,12 +30,12 @@ namespace Kratos using namespace boost::python; - BOOST_PYTHON_MODULE(KratosPfemBaseApplication) + BOOST_PYTHON_MODULE(KratosPfemApplication ) { - class_, boost::noncopyable >("KratosPfemBaseApplication") + class_, boost::noncopyable >("KratosPfemApplication") ; AddCustomProcessesToPython(); diff --git a/applications/PfemBaseApplication/custom_utilities/boundary_normals_calculation_utilities.hpp b/applications/PfemApplication/custom_utilities/boundary_normals_calculation_utilities.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_utilities/boundary_normals_calculation_utilities.hpp rename to applications/PfemApplication/custom_utilities/boundary_normals_calculation_utilities.hpp index f8a8a8f6d689..af3ff7bc06ca 100644 --- a/applications/PfemBaseApplication/custom_utilities/boundary_normals_calculation_utilities.hpp +++ b/applications/PfemApplication/custom_utilities/boundary_normals_calculation_utilities.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -22,7 +22,7 @@ // Project includes #include "includes/kratos_flags.h" #include "utilities/math_utils.h" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos { diff --git a/applications/PfemBaseApplication/custom_utilities/change_tip_elements_utilities.hpp b/applications/PfemApplication/custom_utilities/change_tip_elements_utilities.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_utilities/change_tip_elements_utilities.hpp rename to applications/PfemApplication/custom_utilities/change_tip_elements_utilities.hpp index c04040f2928d..9181dc43cf36 100755 --- a/applications/PfemBaseApplication/custom_utilities/change_tip_elements_utilities.hpp +++ b/applications/PfemApplication/custom_utilities/change_tip_elements_utilities.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -27,7 +27,7 @@ #include "includes/model_part.h" #include "geometries/triangle_2d_3.h" #include "spatial_containers/spatial_containers.h" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" #if !defined(KRATOS_TRIANGLE_EXTERNAL_H_INCLUDED) #define KRATOS_TRIANGLE_EXTERNAL_H_INCLUDED diff --git a/applications/PfemBaseApplication/custom_utilities/mesh_data_transfer_utilities.cpp b/applications/PfemApplication/custom_utilities/mesh_data_transfer_utilities.cpp similarity index 99% rename from applications/PfemBaseApplication/custom_utilities/mesh_data_transfer_utilities.cpp rename to applications/PfemApplication/custom_utilities/mesh_data_transfer_utilities.cpp index 1bdc6ee8d50d..30c8a7997e89 100644 --- a/applications/PfemBaseApplication/custom_utilities/mesh_data_transfer_utilities.cpp +++ b/applications/PfemApplication/custom_utilities/mesh_data_transfer_utilities.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -11,7 +11,7 @@ #include "includes/kratos_flags.h" #include "custom_utilities/mesh_data_transfer_utilities.hpp" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos { diff --git a/applications/PfemBaseApplication/custom_utilities/mesh_data_transfer_utilities.hpp b/applications/PfemApplication/custom_utilities/mesh_data_transfer_utilities.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_utilities/mesh_data_transfer_utilities.hpp rename to applications/PfemApplication/custom_utilities/mesh_data_transfer_utilities.hpp index db4a56199207..ac818040182c 100644 --- a/applications/PfemBaseApplication/custom_utilities/mesh_data_transfer_utilities.hpp +++ b/applications/PfemApplication/custom_utilities/mesh_data_transfer_utilities.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -48,7 +48,7 @@ namespace Kratos /// Short class definition. /** Detail class definition. */ - class KRATOS_API(PFEM_BASE_APPLICATION) MeshDataTransferUtilities + class KRATOS_API(PFEM_APPLICATION) MeshDataTransferUtilities { public: diff --git a/applications/PfemBaseApplication/custom_utilities/mesh_error_calculation_utilities.hpp b/applications/PfemApplication/custom_utilities/mesh_error_calculation_utilities.hpp similarity index 98% rename from applications/PfemBaseApplication/custom_utilities/mesh_error_calculation_utilities.hpp rename to applications/PfemApplication/custom_utilities/mesh_error_calculation_utilities.hpp index 59b49b0dda3d..d7e1a4c44613 100644 --- a/applications/PfemBaseApplication/custom_utilities/mesh_error_calculation_utilities.hpp +++ b/applications/PfemApplication/custom_utilities/mesh_error_calculation_utilities.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -24,7 +24,7 @@ #include "includes/model_part.h" #include "custom_utilities/modeler_utilities.hpp" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" ///VARIABLES used: //Data: NEIGHBOUR_ELEMENTS @@ -59,7 +59,7 @@ namespace Kratos /// Short class definition. /** Computes mesh error for a given variable. Setting the error to elements or nodes for 2D and 3D */ - class KRATOS_API(PFEM_BASE_APPLICATION) MeshErrorCalculationUtilities + class KRATOS_API(PFEM_APPLICATION) MeshErrorCalculationUtilities { public: diff --git a/applications/PfemBaseApplication/custom_utilities/modeler_utilities.cpp b/applications/PfemApplication/custom_utilities/modeler_utilities.cpp similarity index 99% rename from applications/PfemBaseApplication/custom_utilities/modeler_utilities.cpp rename to applications/PfemApplication/custom_utilities/modeler_utilities.cpp index f7ca818d6da3..599c88919f51 100644 --- a/applications/PfemBaseApplication/custom_utilities/modeler_utilities.cpp +++ b/applications/PfemApplication/custom_utilities/modeler_utilities.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemBaseApplication/custom_utilities/modeler_utilities.hpp b/applications/PfemApplication/custom_utilities/modeler_utilities.hpp similarity index 99% rename from applications/PfemBaseApplication/custom_utilities/modeler_utilities.hpp rename to applications/PfemApplication/custom_utilities/modeler_utilities.hpp index c7ede106f211..d98cfbd97715 100644 --- a/applications/PfemBaseApplication/custom_utilities/modeler_utilities.hpp +++ b/applications/PfemApplication/custom_utilities/modeler_utilities.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -21,7 +21,7 @@ #include "custom_utilities/mesh_data_transfer_utilities.hpp" //#include "includes/kratos_flags.h" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos { @@ -47,7 +47,7 @@ namespace Kratos /// Short class definition. /** Detail class definition. */ -class KRATOS_API(PFEM_BASE_APPLICATION) ModelerUtilities +class KRATOS_API(PFEM_APPLICATION) ModelerUtilities { public: diff --git a/applications/PfemBaseApplication/license.txt b/applications/PfemApplication/license.txt similarity index 93% rename from applications/PfemBaseApplication/license.txt rename to applications/PfemApplication/license.txt index 245f9a815492..63f104e5e414 100644 --- a/applications/PfemBaseApplication/license.txt +++ b/applications/PfemApplication/license.txt @@ -1,4 +1,4 @@ -Kratos Pfem Base Application +Kratos Pfem Application Copyright (c) 2016, Josep Maria Carbonell i Puigbó All rights reserved. @@ -15,7 +15,7 @@ provided that the following conditions are met: 3. All advertising materials mentioning features or use of this software must display the following acknowledgement: - This product includes Kratos Pfem Base technology. + This product includes Kratos Pfem technology. 4. Neither the name of the copyright holder nor the names of its contributors may be used to endorse or promote products derived from this software without specific prior written permission. diff --git a/applications/PfemBaseApplication/pfem_base_application.cpp b/applications/PfemApplication/pfem_application.cpp similarity index 76% rename from applications/PfemBaseApplication/pfem_base_application.cpp rename to applications/PfemApplication/pfem_application.cpp index b563cf9c5d9c..2390e0d90346 100644 --- a/applications/PfemBaseApplication/pfem_base_application.cpp +++ b/applications/PfemApplication/pfem_application.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -31,28 +31,28 @@ #include "includes/variables.h" // Core applications -#include "pfem_base_application.h" +#include "pfem_application.h" namespace Kratos { //Create Variables - KratosPfemBaseApplication::KratosPfemBaseApplication(): + KratosPfemApplication ::KratosPfemApplication (): mCompositeCondition2D2N( 0, Condition::GeometryType::Pointer( new Line2D2 >( Condition::GeometryType::PointsArrayType( 2 ) ) ) ), mCompositeCondition3D3N( 0, Condition::GeometryType::Pointer( new Triangle3D3 >( Condition::GeometryType::PointsArrayType( 3 ) ) ) ) {} - void KratosPfemBaseApplication::Register() + void KratosPfemApplication ::Register() { // calling base class register to register Kratos components KratosApplication::Register(); - std::cout << " ___ __ ___ " << std::endl; - std::cout << " KRATOS| _ \\/ _|___ _ __ | _ ) __ _ ___ ___ " << std::endl; - std::cout << " | _/ _/ -_) ' \\| _ \\/ _` (_-::GetComponents().size() ) rOStream << "Variables:" << std::endl; KratosComponents().PrintData(rOStream); @@ -227,15 +227,15 @@ namespace Kratos ///@{ /// Assignment operator. - KratosPfemBaseApplication& operator=(KratosPfemBaseApplication const& rOther); + KratosPfemApplication& operator=(KratosPfemApplication const& rOther); /// Copy constructor. - KratosPfemBaseApplication(KratosPfemBaseApplication const& rOther); + KratosPfemApplication(KratosPfemApplication const& rOther); ///@} - }; // Class KratosPfemBaseApplication + }; // Class KratosPfemApplication ///@} @@ -253,6 +253,6 @@ namespace Kratos } // namespace Kratos. -#endif // KRATOS_PFEM_BASE_APPLICATION_H_INCLUDED defined +#endif // KRATOS_PFEM_APPLICATION_H_INCLUDED defined diff --git a/applications/PfemBaseApplication/pfem_base_application_variables.cpp b/applications/PfemApplication/pfem_application_variables.cpp similarity index 92% rename from applications/PfemBaseApplication/pfem_base_application_variables.cpp rename to applications/PfemApplication/pfem_application_variables.cpp index 58d9017658d0..15da1e3fc192 100644 --- a/applications/PfemBaseApplication/pfem_base_application_variables.cpp +++ b/applications/PfemApplication/pfem_application_variables.cpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ @@ -7,7 +7,7 @@ // // -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos { diff --git a/applications/PfemApplication/pfem_application_variables.h b/applications/PfemApplication/pfem_application_variables.h new file mode 100644 index 000000000000..2693599e89da --- /dev/null +++ b/applications/PfemApplication/pfem_application_variables.h @@ -0,0 +1,79 @@ +//------------------------------------------------------------- +// ___ __ +// KRATOS| _ \/ _|___ _ __ +// | _/ _/ -_) ' \ +// |_| |_| \___|_|_|_|APPLICATION +// +// License:(BSD) PfemFluidMechanicsApplication/license.txt +// +// Main authors: Josep Maria Carbonell +// .. +//------------------------------------------------------------- +// +// Project Name: KratosPfemApplication $ +// Created by: $Author: JMCarbonell $ +// Last modified by: $Co-Author: $ +// Date: $Date: February 2016 $ +// Revision: $Revision: 0.0 $ +// +// + +#if !defined(KRATOS_PFEM_APPLICATION_VARIABLES_H_INCLUDED ) +#define KRATOS_PFEM_APPLICATION_VARIABLES_H_INCLUDED + +// System includes + +// External includes + +// Project includes +#include "includes/define.h" +#include "includes/variables.h" +#include "includes/kratos_flags.h" +#include "includes/kratos_application.h" + + +namespace Kratos +{ + ///@name Type Definitions + ///@{ + typedef array_1d Vector3; + typedef array_1d Vector6; + typedef PointerVectorSet ConditionContainerType; + ///@} + + ///@name Kratos Globals + ///@{ + + //Define Variables + + //nodal dofs + KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS( PFEM_APPLICATION, OFFSET ) + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, double, SHRINK_FACTOR ) + + + + //domain definition + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, bool, INITIALIZED_DOMAINS ) + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, bool, MESHING_STEP_PERFORMED ) + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, std::string, MODEL_PART_NAME ) + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, unsigned int, DOMAIN_LABEL ) + + + //boundary definition + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, int, RIGID_WALL ) + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, Condition::Pointer, MASTER_CONDITION ) + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, WeakPointerVector< Element >, MASTER_ELEMENTS ) + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, WeakPointerVector< Node<3> >, MASTER_NODES ) + + //condition variables + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, ConditionContainerType, CHILDREN_CONDITIONS) + + //modeler criteria + KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_APPLICATION, double, MEAN_ERROR ) + + + ///@} + +} + +#endif /* KRATOS_PFEM_APPLICATION_VARIABLES_H_INCLUDED */ diff --git a/applications/PfemBaseApplication/python_scripts/constant_rotation_process.py b/applications/PfemApplication/python_scripts/constant_rotation_process.py similarity index 88% rename from applications/PfemBaseApplication/python_scripts/constant_rotation_process.py rename to applications/PfemApplication/python_scripts/constant_rotation_process.py index a9e129a2f043..ce3870b34730 100644 --- a/applications/PfemBaseApplication/python_scripts/constant_rotation_process.py +++ b/applications/PfemApplication/python_scripts/constant_rotation_process.py @@ -1,5 +1,5 @@ import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication +import KratosMultiphysics.PfemApplication def Factory(settings, Model): if(type(settings) != KratosMultiphysics.Parameters): @@ -16,7 +16,7 @@ def __init__(self, Model, settings ): name_of_submodelpart = settings["model_part_name"].GetString() self.model_part = Model[name_of_submodelpart] - self.cplusplus_version_process = KratosMultiphysics.PfemBaseApplication.ConstantRotationProcess(self.model_part, settings) + self.cplusplus_version_process = KratosMultiphysics.PfemApplication.ConstantRotationProcess(self.model_part, settings) def ExecuteInitializeSolutionStep(self): self.cplusplus_version_process.ExecuteInitializeSolutionStep() diff --git a/applications/PfemBaseApplication/python_scripts/domain_utilities.py b/applications/PfemApplication/python_scripts/domain_utilities.py similarity index 82% rename from applications/PfemBaseApplication/python_scripts/domain_utilities.py rename to applications/PfemApplication/python_scripts/domain_utilities.py index 69a959197cd2..3e72e3519724 100644 --- a/applications/PfemBaseApplication/python_scripts/domain_utilities.py +++ b/applications/PfemApplication/python_scripts/domain_utilities.py @@ -1,6 +1,6 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem KratosMultiphysics.CheckForPreviousImport() class DomainUtilities(object): @@ -12,7 +12,7 @@ def __init__(self): # def InitializeDomains(self, model_part, echo_level): - if( model_part.ProcessInfo[KratosPfemBase.INITIALIZED_DOMAINS] == False ): + if( model_part.ProcessInfo[KratosPfem.INITIALIZED_DOMAINS] == False ): # initialize the modeler print("::[Domain_Utilities]:: Initialize", model_part.Name) @@ -25,7 +25,7 @@ def InitializeDomains(self, model_part, echo_level): # set modeler utilities - modeler_utils = KratosPfemBase.ModelerUtilities() + modeler_utils = KratosPfem.ModelerUtilities() # set the domain labels to conditions modeler_utils.SetModelPartNameToConditions(model_part) @@ -42,7 +42,7 @@ def InitializeDomains(self, model_part, echo_level): modeler_utils.SetModelPartNameToNodes(model_part) - model_part.ProcessInfo.SetValue(KratosPfemBase.INITIALIZED_DOMAINS, True) + model_part.ProcessInfo.SetValue(KratosPfem.INITIALIZED_DOMAINS, True) print("::[Domain_Utilities]:: Resultant ModelPart") print(model_part) @@ -58,7 +58,7 @@ def SearchNodeNeighbours(self, model_part, echo_level): number_of_avg_nodes = 10 # define search utility - nodal_neighbour_search = KratosPfemBase.NodalNeighboursSearch(model_part, echo_level, number_of_avg_elems, number_of_avg_nodes, mesh_id) + nodal_neighbour_search = KratosPfem.NodalNeighboursSearch(model_part, echo_level, number_of_avg_elems, number_of_avg_nodes, mesh_id) # execute search: nodal_neighbour_search.Execute() @@ -75,7 +75,7 @@ def SearchElementNeighbours(self, model_part, echo_level): number_of_avg_elems = 10 # define search utility - elemental_neighbour_search = KratosPfemBase.ElementalNeighboursSearch(model_part, domain_size, echo_level, number_of_avg_elems, mesh_id) + elemental_neighbour_search = KratosPfem.ElementalNeighboursSearch(model_part, domain_size, echo_level, number_of_avg_elems, mesh_id) # execute search: elemental_neighbour_search.Execute() @@ -94,7 +94,7 @@ def BuildModelPartBoundary(self, model_part, echo_level): # define building utility - skin_build = KratosPfemBase.BuildModelPartBoundary(model_part, model_part.Name, echo_level) + skin_build = KratosPfem.BuildModelPartBoundary(model_part, model_part.Name, echo_level) # execute building: skin_build.Execute() @@ -124,7 +124,7 @@ def SearchNodalH(self, model_part, echo_level): def ComputeBoundaryNormals(self, model_part, echo_level): # define calculation utility - normals_calculation = KratosPfemBase.BoundaryNormalsCalculation() + normals_calculation = KratosPfem.BoundaryNormalsCalculation() # execute calculation: #(scaled normals) diff --git a/applications/PfemBaseApplication/python_scripts/mesh_modeler.py b/applications/PfemApplication/python_scripts/mesh_modeler.py similarity index 66% rename from applications/PfemBaseApplication/python_scripts/mesh_modeler.py rename to applications/PfemApplication/python_scripts/mesh_modeler.py index 8acf5bd75411..71ce3d80a402 100644 --- a/applications/PfemBaseApplication/python_scripts/mesh_modeler.py +++ b/applications/PfemApplication/python_scripts/mesh_modeler.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem # Check that KratosMultiphysics was imported in the main script KratosMultiphysics.CheckForPreviousImport() @@ -31,9 +31,9 @@ def Initialize(self, domain_size): # set mesh modeler if(self.domain_size == 2): - self.mesher = KratosPfemBase.TriangularMesh2DModeler() + self.mesher = KratosPfem.TriangularMesh2DModeler() elif(self.domain_size == 3): - self.mesher = KratosPfemBase.TetrahedralMesh3DModeler() + self.mesher = KratosPfem.TetrahedralMesh3DModeler() self.mesher.SetEchoLevel(self.echo_level) self.mesher.SetMeshingParameters(self.MeshingParameters) @@ -52,16 +52,16 @@ def InitializeMeshing(self): # set execution flags: to set the options to be executed in methods and processes execution_options = KratosMultiphysics.Flags() - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, False) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, False) self.MeshingParameters.SetExecutionOptions(execution_options) @@ -109,7 +109,7 @@ def SetPreMeshingProcesses(self): # process to refine elements / refine boundary - refine_mesh_elements = KratosPfemBase.SetElementNodesToRefineOnThreshold(self.model_part, self.MeshingParameters, self.echo_level) + refine_mesh_elements = KratosPfem.SetElementNodesToRefineOnThreshold(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPreMeshingProcess(refine_mesh_elements) # process to refine boundary / contact boundary @@ -118,7 +118,7 @@ def SetPreMeshingProcesses(self): # process to remove nodes / remove boundary - remove_mesh_nodes = KratosPfemBase.RemoveMeshNodes(self.model_part, self.MeshingParameters, self.echo_level) + remove_mesh_nodes = KratosPfem.RemoveMeshNodes(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPreMeshingProcess(remove_mesh_nodes) @@ -128,19 +128,19 @@ def SetPostMeshingProcesses(self): # The order set is the order of execution: #generate new particles - generate_particles = KratosPfemBase.GenerateNewNodes(self.model_part, self.MeshingParameters, self.echo_level) + generate_particles = KratosPfem.GenerateNewNodes(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(generate_particles) #select mesh elements - select_mesh_elements = KratosPfemBase.SelectMeshElements(self.model_part, self.MeshingParameters, self.echo_level) + select_mesh_elements = KratosPfem.SelectMeshElements(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(select_mesh_elements) #rebuild elements - rebuild_mesh_elements = KratosPfemBase.BuildMeshElements(self.model_part, self.MeshingParameters, self.echo_level) + rebuild_mesh_elements = KratosPfem.BuildMeshElements(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(rebuild_mesh_elements) #rebuild boundary - rebuild_mesh_boundary = KratosPfemBase.BuildMeshBoundary(self.model_part, self.MeshingParameters, self.echo_level) + rebuild_mesh_boundary = KratosPfem.BuildMeshBoundary(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(rebuild_mesh_boundary) # @@ -150,16 +150,16 @@ def FinalizeMeshing(self): execution_options = KratosMultiphysics.Flags() # all flags - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, False) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, False) self.MeshingParameters.SetExecutionOptions(execution_options) diff --git a/applications/PfemBaseApplication/python_scripts/meshing_domain.py b/applications/PfemApplication/python_scripts/meshing_domain.py similarity index 77% rename from applications/PfemBaseApplication/python_scripts/meshing_domain.py rename to applications/PfemApplication/python_scripts/meshing_domain.py index f41ee6733452..97518e756039 100644 --- a/applications/PfemBaseApplication/python_scripts/meshing_domain.py +++ b/applications/PfemApplication/python_scripts/meshing_domain.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem # Check that KratosMultiphysics was imported in the main script KratosMultiphysics.CheckForPreviousImport() @@ -130,14 +130,14 @@ def Initialize(self): def SetInfoParameters(self): # Create InfoParameters - self.InfoParameters = KratosPfemBase.MeshingInfoParameters() + self.InfoParameters = KratosPfem.MeshingInfoParameters() self.InfoParameters.Initialize() # def SetTransferParameters(self): # Create TransferParameters - self.TransferParameters = KratosPfemBase.TransferParameters() + self.TransferParameters = KratosPfem.TransferParameters() transfer_variables = self.settings["elemental_variables_to_transfer"] #for variable in transfer_variables: # self.TransferParameters.SetVariable( KratosMultiphysics.KratosGlobals.GetVariable( variable.GetString() ) ) @@ -148,7 +148,7 @@ def SetTransferParameters(self): def SetRefiningParameters(self): # Create RefiningParameters - self.RefiningParameters = KratosPfemBase.RefiningParameters() + self.RefiningParameters = KratosPfem.RefiningParameters() self.RefiningParameters.Initialize() # parameters @@ -169,7 +169,7 @@ def SetRefiningParameters(self): center[i] = refining_box["center"][i].GetDouble() velocity[i] = refining_box["velocity"][i].GetDouble() - refining_box = KratosPfemBase.SpatialBoundingBox(center, radius, velocity) + refining_box = KratosPfem.SpatialBoundingBox(center, radius, velocity) self.RefiningParameters.SetRefiningBox(refining_box) self.RefiningParameters.SetThresholdVariable(KratosMultiphysics.KratosGlobals.GetVariable(self.settings["refining_parameters"]["threshold_variable"].GetString() )) @@ -183,36 +183,36 @@ def SetRefiningParameters(self): #remove nodes remove_nodes = self.settings["refining_parameters"]["remove_nodes"] - removing_options.Set(KratosPfemBase.ModelerUtilities.REMOVE_NODES, remove_nodes["apply_removal"].GetBool()) - removing_options.Set(KratosPfemBase.ModelerUtilities.REMOVE_NODES_ON_DISTANCE, remove_nodes["on_distance"].GetBool()) - removing_options.Set(KratosPfemBase.ModelerUtilities.REMOVE_NODES_ON_ERROR, remove_nodes["on_error"].GetBool()) - removing_options.Set(KratosPfemBase.ModelerUtilities.REMOVE_NODES_ON_THRESHOLD, remove_nodes["on_threshold"].GetBool()) + removing_options.Set(KratosPfem.ModelerUtilities.REMOVE_NODES, remove_nodes["apply_removal"].GetBool()) + removing_options.Set(KratosPfem.ModelerUtilities.REMOVE_NODES_ON_DISTANCE, remove_nodes["on_distance"].GetBool()) + removing_options.Set(KratosPfem.ModelerUtilities.REMOVE_NODES_ON_ERROR, remove_nodes["on_error"].GetBool()) + removing_options.Set(KratosPfem.ModelerUtilities.REMOVE_NODES_ON_THRESHOLD, remove_nodes["on_threshold"].GetBool()) #remove boundary remove_boundary = self.settings["refining_parameters"]["remove_boundary"] - removing_options.Set(KratosPfemBase.ModelerUtilities.REMOVE_BOUNDARY_NODES, remove_boundary["apply_removal"].GetBool()) - removing_options.Set(KratosPfemBase.ModelerUtilities.REMOVE_BOUNDARY_NODES_ON_DISTANCE, remove_boundary["on_distance"].GetBool()) - removing_options.Set(KratosPfemBase.ModelerUtilities.REMOVE_BOUNDARY_NODES_ON_ERROR, remove_boundary["on_error"].GetBool()) - removing_options.Set(KratosPfemBase.ModelerUtilities.REMOVE_BOUNDARY_NODES_ON_THRESHOLD, remove_boundary["on_threshold"].GetBool()) + removing_options.Set(KratosPfem.ModelerUtilities.REMOVE_BOUNDARY_NODES, remove_boundary["apply_removal"].GetBool()) + removing_options.Set(KratosPfem.ModelerUtilities.REMOVE_BOUNDARY_NODES_ON_DISTANCE, remove_boundary["on_distance"].GetBool()) + removing_options.Set(KratosPfem.ModelerUtilities.REMOVE_BOUNDARY_NODES_ON_ERROR, remove_boundary["on_error"].GetBool()) + removing_options.Set(KratosPfem.ModelerUtilities.REMOVE_BOUNDARY_NODES_ON_THRESHOLD, remove_boundary["on_threshold"].GetBool()) refining_options = KratosMultiphysics.Flags() - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE, self.settings["meshing_strategy"]["refine"].GetBool()) - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_ADD_NODES, self.settings["refining_parameters"]["add_nodes"].GetBool()) - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES, self.settings["refining_parameters"]["insert_nodes"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE, self.settings["meshing_strategy"]["refine"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_ADD_NODES, self.settings["refining_parameters"]["add_nodes"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES, self.settings["refining_parameters"]["insert_nodes"].GetBool()) #refine elements refine_elements = self.settings["refining_parameters"]["refine_elements"] - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_ELEMENTS, refine_elements["apply_refinement"].GetBool()) - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_ELEMENTS_ON_DISTANCE, refine_elements["on_distance"].GetBool()) - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_ELEMENTS_ON_ERROR, refine_elements["on_error"].GetBool()) - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_ELEMENTS_ON_THRESHOLD, refine_elements["on_threshold"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_ELEMENTS, refine_elements["apply_refinement"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_ELEMENTS_ON_DISTANCE, refine_elements["on_distance"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_ELEMENTS_ON_ERROR, refine_elements["on_error"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_ELEMENTS_ON_THRESHOLD, refine_elements["on_threshold"].GetBool()) #refine boundary refine_boundary = self.settings["refining_parameters"]["refine_boundary"] - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_BOUNDARY, refine_boundary["apply_refinement"].GetBool()) - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_BOUNDARY_ON_DISTANCE, refine_boundary["on_distance"].GetBool()) - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_BOUNDARY_ON_ERROR, refine_boundary["on_error"].GetBool()) - refining_options.Set(KratosPfemBase.ModelerUtilities.REFINE_BOUNDARY_ON_THRESHOLD, refine_boundary["on_threshold"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_BOUNDARY, refine_boundary["apply_refinement"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_BOUNDARY_ON_DISTANCE, refine_boundary["on_distance"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_BOUNDARY_ON_ERROR, refine_boundary["on_error"].GetBool()) + refining_options.Set(KratosPfem.ModelerUtilities.REFINE_BOUNDARY_ON_THRESHOLD, refine_boundary["on_threshold"].GetBool()) self.RefiningParameters.SetRefiningOptions(refining_options) self.RefiningParameters.SetRemovingOptions(removing_options) @@ -221,7 +221,7 @@ def SetRefiningParameters(self): def SetMeshingParameters(self): # Create MeshingParameters - self.MeshingParameters = KratosPfemBase.MeshingParameters() + self.MeshingParameters = KratosPfem.MeshingParameters() self.MeshingParameters.Initialize() self.MeshingParameters.SetMeshId(self.settings["mesh_id"].GetInt()) @@ -270,7 +270,7 @@ def SetMeshSizeValues(self): def Check(self): # set modeler utilities - self.modeler_utils = KratosPfemBase.ModelerUtilities() + self.modeler_utils = KratosPfem.ModelerUtilities() # set the domain labels to mesh modeler critical_mesh_size = self.settings["refining_parameters"]["critical_size"].GetDouble() diff --git a/applications/PfemBaseApplication/python_scripts/meshing_strategy.py b/applications/PfemApplication/python_scripts/meshing_strategy.py similarity index 88% rename from applications/PfemBaseApplication/python_scripts/meshing_strategy.py rename to applications/PfemApplication/python_scripts/meshing_strategy.py index a895b761f407..25bc7bf9fa8e 100644 --- a/applications/PfemBaseApplication/python_scripts/meshing_strategy.py +++ b/applications/PfemApplication/python_scripts/meshing_strategy.py @@ -2,7 +2,7 @@ #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem # Check that KratosMultiphysics was imported in the main script KratosMultiphysics.CheckForPreviousImport() @@ -55,21 +55,21 @@ def Initialize(self,meshing_parameters,domain_size): meshing_options = KratosMultiphysics.Flags() - meshing_options.Set(KratosPfemBase.ModelerUtilities.REMESH, self.settings["remesh"].GetBool()) - meshing_options.Set(KratosPfemBase.ModelerUtilities.REFINE, self.settings["refine"].GetBool()) - meshing_options.Set(KratosPfemBase.ModelerUtilities.RECONNECT, self.settings["reconnect"].GetBool()) - meshing_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER, self.settings["transfer"].GetBool()) - meshing_options.Set(KratosPfemBase.ModelerUtilities.CONSTRAINED, self.settings["constrained"].GetBool()) - meshing_options.Set(KratosPfemBase.ModelerUtilities.MESH_SMOOTHING, self.settings["mesh_smoothing"].GetBool()) - meshing_options.Set(KratosPfemBase.ModelerUtilities.VARIABLES_SMOOTHING, self.settings["variables_smoothing"].GetBool()) + meshing_options.Set(KratosPfem.ModelerUtilities.REMESH, self.settings["remesh"].GetBool()) + meshing_options.Set(KratosPfem.ModelerUtilities.REFINE, self.settings["refine"].GetBool()) + meshing_options.Set(KratosPfem.ModelerUtilities.RECONNECT, self.settings["reconnect"].GetBool()) + meshing_options.Set(KratosPfem.ModelerUtilities.TRANSFER, self.settings["transfer"].GetBool()) + meshing_options.Set(KratosPfem.ModelerUtilities.CONSTRAINED, self.settings["constrained"].GetBool()) + meshing_options.Set(KratosPfem.ModelerUtilities.MESH_SMOOTHING, self.settings["mesh_smoothing"].GetBool()) + meshing_options.Set(KratosPfem.ModelerUtilities.VARIABLES_SMOOTHING, self.settings["variables_smoothing"].GetBool()) self.MeshingParameters.SetOptions(meshing_options) self.MeshingParameters.SetReferenceElement(self.settings["reference_element_type"].GetString()) self.MeshingParameters.SetReferenceCondition(self.settings["reference_condition_type"].GetString()) #set variables to global transfer - self.MeshDataTransfer = KratosPfemBase.MeshDataTransferUtilities() - self.TransferParameters = KratosPfemBase.TransferParameters() + self.MeshDataTransfer = KratosPfem.MeshDataTransferUtilities() + self.TransferParameters = KratosPfem.TransferParameters() self.global_transfer = False if( self.settings["variables_smoothing"].GetBool() == True ): self.global_transfer = True diff --git a/applications/PfemBaseApplication/python_scripts/post_refining_modeler.py b/applications/PfemApplication/python_scripts/post_refining_modeler.py similarity index 73% rename from applications/PfemBaseApplication/python_scripts/post_refining_modeler.py rename to applications/PfemApplication/python_scripts/post_refining_modeler.py index 0bc04300066a..2b56fec062c8 100644 --- a/applications/PfemBaseApplication/python_scripts/post_refining_modeler.py +++ b/applications/PfemApplication/python_scripts/post_refining_modeler.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem # Check that KratosMultiphysics was imported in the main script KratosMultiphysics.CheckForPreviousImport() @@ -38,30 +38,30 @@ def InitializeMeshing(self): if( self.domain_size == 2 ): - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_ADD_NODES) ): + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_ADD_NODES) ): #"YYJaqrn" "YJq1.4arn" "Jq1.4arn" - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pYJq1.4arnCQ" else: modeler_flags = "YJq1.4arnQ" - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES) ): + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES) ): #"riYYJQ" "riYYJQ" "riJQ" "riQ" - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "rinYYJQ" else: modeler_flags = "rinJQ" elif( self.domain_size == 3 ): - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_ADD_NODES) ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_ADD_NODES) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pMYJq1.4arnCBQF" else: modeler_flags = "YJq1.4arnBQF" - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES) ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "rinYYJBQF" else: modeler_flags = "rinJBQF" diff --git a/applications/PfemBaseApplication/python_scripts/pre_refining_modeler.py b/applications/PfemApplication/python_scripts/pre_refining_modeler.py similarity index 55% rename from applications/PfemBaseApplication/python_scripts/pre_refining_modeler.py rename to applications/PfemApplication/python_scripts/pre_refining_modeler.py index 8517fda1c608..2a541ab32496 100644 --- a/applications/PfemBaseApplication/python_scripts/pre_refining_modeler.py +++ b/applications/PfemApplication/python_scripts/pre_refining_modeler.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem # Check that KratosMultiphysics was imported in the main script KratosMultiphysics.CheckForPreviousImport() @@ -31,18 +31,18 @@ def InitializeMeshing(self): execution_options = KratosMultiphysics.Flags() - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, False) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, False) self.MeshingParameters.SetExecutionOptions(execution_options) @@ -54,7 +54,7 @@ def InitializeMeshing(self): modeler_info = "Prepare domain for refinement" if( self.domain_size == 2 ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pnBYYQ" else: modeler_flags = "nQP" @@ -62,7 +62,7 @@ def InitializeMeshing(self): elif( self.domain_size == 3 ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pnBJFMYYQ" else: modeler_flags = "nJFMQO4/4" @@ -76,19 +76,19 @@ def SetPreMeshingProcesses(self): # process to refine elements /refine boundary - refine_mesh_elements = KratosPfemBase.SetElementNodesToRefineOnThreshold(self.model_part, self.MeshingParameters, self.echo_level) + refine_mesh_elements = KratosPfem.SetElementNodesToRefineOnThreshold(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPreMeshingProcess(refine_mesh_elements) - refine_edge_elements = KratosPfemBase.SetElementEdgesToRefine(self.model_part,self.MeshingParameters,self.echo_level) + refine_edge_elements = KratosPfem.SetElementEdgesToRefine(self.model_part,self.MeshingParameters,self.echo_level) self.mesher.SetPreMeshingProcess(refine_edge_elements) - refine_mesh_boundary = KratosPfemBase.RefineMeshBoundary(self.model_part, self.MeshingParameters, self.echo_level) + refine_mesh_boundary = KratosPfem.RefineMeshBoundary(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPreMeshingProcess(refine_mesh_boundary) # process to remove nodes / remove boundary - remove_mesh_nodes = KratosPfemBase.RemoveMeshNodes(self.model_part, self.MeshingParameters, self.echo_level) + remove_mesh_nodes = KratosPfem.RemoveMeshNodes(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPreMeshingProcess(remove_mesh_nodes) @@ -101,15 +101,15 @@ def SetPostMeshingProcesses(self): refining_options = refining_parameters.GetRefiningOptions() #select mesh elements - select_mesh_elements = KratosPfemBase.SelectMeshElements(self.model_part, self.MeshingParameters, self.echo_level) + select_mesh_elements = KratosPfem.SelectMeshElements(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(select_mesh_elements) - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_ADD_NODES) ): - select_refine_elements = KratosPfemBase.SetElementsToRefineOnSize(self.model_part, self.MeshingParameters, self.echo_level) + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_ADD_NODES) ): + select_refine_elements = KratosPfem.SetElementsToRefineOnSize(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(select_refine_elements) - #if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES) ): + #if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES) ): #insert_nodes = InsertNodes(self.model_part, self.MeshingParameters, self.echo_level) #self.mesher.SetPostMeshingProcess(insert_nodes) @@ -126,21 +126,21 @@ def FinalizeMeshing(self): execution_options = KratosMultiphysics.Flags() # set for the post_refining process - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES) ): + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) meshing_options = self.MeshingParameters.GetOptions() - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_ADD_NODES) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_ADD_NODES) ): + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, False) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, False) self.MeshingParameters.SetExecutionOptions(execution_options) diff --git a/applications/PfemBaseApplication/python_scripts/reconnect_modeler.py b/applications/PfemApplication/python_scripts/reconnect_modeler.py similarity index 66% rename from applications/PfemBaseApplication/python_scripts/reconnect_modeler.py rename to applications/PfemApplication/python_scripts/reconnect_modeler.py index 16a3fe0b524e..5b9a8fcbbc18 100644 --- a/applications/PfemBaseApplication/python_scripts/reconnect_modeler.py +++ b/applications/PfemApplication/python_scripts/reconnect_modeler.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem # Check that KratosMultiphysics was imported in the main script KratosMultiphysics.CheckForPreviousImport() @@ -31,20 +31,20 @@ def InitializeMeshing(self): # set execution flags: to set the options to be executed in methods and processes execution_options = KratosMultiphysics.Flags() - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) else: - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, False) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, False) self.MeshingParameters.SetExecutionOptions(execution_options) @@ -55,7 +55,7 @@ def InitializeMeshing(self): modeler_info = "Reconnect a cloud of points" if( self.domain_size == 2 ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pnBYYQ" else: modeler_flags = "nQP" @@ -63,7 +63,7 @@ def InitializeMeshing(self): elif( self.domain_size == 3 ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pnBFMYYQ" else: modeler_flags = "nBFMQ" # "QJFu0" (1.4.3) "nJFMQO4/4" (1.5.0) diff --git a/applications/PfemBaseApplication/python_scripts/remesh_domains_process.py b/applications/PfemApplication/python_scripts/remesh_domains_process.py similarity index 92% rename from applications/PfemBaseApplication/python_scripts/remesh_domains_process.py rename to applications/PfemApplication/python_scripts/remesh_domains_process.py index 9c2511e6122a..031f40887e87 100644 --- a/applications/PfemBaseApplication/python_scripts/remesh_domains_process.py +++ b/applications/PfemApplication/python_scripts/remesh_domains_process.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem KratosMultiphysics.CheckForPreviousImport() #from multiprocessing import Pool @@ -86,7 +86,7 @@ def ExecuteInitialize(self): self.next_meshing = self.meshing_frequency # it must be initialized if restart is called//no - self.main_model_part.ProcessInfo.SetValue(KratosPfemBase.INITIALIZED_DOMAINS, False); + self.main_model_part.ProcessInfo.SetValue(KratosPfem.INITIALIZED_DOMAINS, False); # initialize all meshing domains if( self.remesh_domains_active ): @@ -114,7 +114,7 @@ def ExecuteBeforeOutputStep(self): if(self.remesh_domains_active): if( self.meshing_before_output ): - self.main_model_part.ProcessInfo[KratosPfemBase.MESHING_STEP_PERFORMED] = False + self.main_model_part.ProcessInfo[KratosPfem.MESHING_STEP_PERFORMED] = False if(self.IsMeshingStep()): self.RemeshDomains() @@ -123,7 +123,7 @@ def ExecuteAfterOutputStep(self): if(self.remesh_domains_active): if( not self.meshing_before_output ): - self.main_model_part.ProcessInfo[KratosPfemBase.MESHING_STEP_PERFORMED] = False + self.main_model_part.ProcessInfo[KratosPfem.MESHING_STEP_PERFORMED] = False if(self.IsMeshingStep()): self.RemeshDomains() @@ -140,7 +140,7 @@ def RemeshDomains(self): print("::[Meshing_Process]:: MESHING DOMAIN...( call:", self.counter,")") meshing_options = KratosMultiphysics.Flags() - self.model_meshing = KratosPfemBase.ModelMeshing(self.main_model_part, meshing_options, self.echo_level) + self.model_meshing = KratosPfem.ModelMeshing(self.main_model_part, meshing_options, self.echo_level) self.model_meshing.ExecuteInitialize() @@ -164,7 +164,7 @@ def RemeshDomains(self): self.counter += 1 - self.main_model_part.ProcessInfo[KratosPfemBase.MESHING_STEP_PERFORMED] = True + self.main_model_part.ProcessInfo[KratosPfem.MESHING_STEP_PERFORMED] = True # schedule next meshing if(self.meshing_frequency > 0.0): # note: if == 0 always active diff --git a/applications/PfemBaseApplication/python_scripts/transfer_modeler.py b/applications/PfemApplication/python_scripts/transfer_modeler.py similarity index 58% rename from applications/PfemBaseApplication/python_scripts/transfer_modeler.py rename to applications/PfemApplication/python_scripts/transfer_modeler.py index 7492b1611277..0eda77a1757e 100644 --- a/applications/PfemBaseApplication/python_scripts/transfer_modeler.py +++ b/applications/PfemApplication/python_scripts/transfer_modeler.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem # Check that KratosMultiphysics was imported in the main script KratosMultiphysics.CheckForPreviousImport() @@ -29,15 +29,15 @@ def InitializeMeshing(self): # set execution flags: to set the options to be executed in methods and processes execution_options = KratosMultiphysics.Flags() - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, False) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, False) self.MeshingParameters.SetExecutionOptions(execution_options) @@ -53,14 +53,14 @@ def SetPostMeshingProcesses(self): #nothing to do: only reconnection #select mesh elements - #select_mesh_elements = KratosPfemBase.SelectMeshElements(self.main_model_part, self.MeshingParameters, self.echo_level) + #select_mesh_elements = KratosPfem.SelectMeshElements(self.main_model_part, self.MeshingParameters, self.echo_level) #self.mesher.SetPostMeshingProcess(select_mesh_elements) #rebuild elements - rebuild_mesh_elements = KratosPfemBase.BuildMeshElements(self.model_part, self.MeshingParameters, self.echo_level) + rebuild_mesh_elements = KratosPfem.BuildMeshElements(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(rebuild_mesh_elements) #rebuild boundary - rebuild_mesh_boundary = KratosPfemBase.ReconstructMeshBoundary(self.model_part, self.MeshingParameters, self.echo_level) + rebuild_mesh_boundary = KratosPfem.ReconstructMeshBoundary(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(rebuild_mesh_boundary) diff --git a/applications/PfemBaseApplication/PfemBaseApplication.py b/applications/PfemBaseApplication/PfemBaseApplication.py deleted file mode 100755 index 493974175253..000000000000 --- a/applications/PfemBaseApplication/PfemBaseApplication.py +++ /dev/null @@ -1,11 +0,0 @@ -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -from KratosPfemBaseApplication import * -application = KratosPfemBaseApplication() -application_name = "KratosPfemBaseApplication" -application_folder = "PfemBaseApplication" - -# The following lines are common for all applications -from . import application_importer -import inspect -caller = inspect.stack()[1] # Information about the file that imported this, to check for unexpected imports -application_importer.ImportApplication(application, application_name, application_folder, caller) diff --git a/applications/PfemBaseApplication/custom_external_libraries/embedded/libgid_mesh_library.a b/applications/PfemBaseApplication/custom_external_libraries/embedded/libgid_mesh_library.a deleted file mode 100644 index 3724b851cdd0..000000000000 Binary files a/applications/PfemBaseApplication/custom_external_libraries/embedded/libgid_mesh_library.a and /dev/null differ diff --git a/applications/PfemBaseApplication/pfem_base_application_variables.h b/applications/PfemBaseApplication/pfem_base_application_variables.h deleted file mode 100644 index d87fb9692d25..000000000000 --- a/applications/PfemBaseApplication/pfem_base_application_variables.h +++ /dev/null @@ -1,79 +0,0 @@ -//------------------------------------------------------------- -// ___ __ ___ -// KRATOS| _ \/ _|___ _ __ | _ ) __ _ ___ ___ -// | _/ _/ -_) ' \| _ \/ _` (_- Vector3; - typedef array_1d Vector6; - typedef PointerVectorSet ConditionContainerType; - ///@} - - ///@name Kratos Globals - ///@{ - - //Define Variables - - //nodal dofs - KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS( PFEM_BASE_APPLICATION, OFFSET ) - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, double, SHRINK_FACTOR ) - - - - //domain definition - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, bool, INITIALIZED_DOMAINS ) - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, bool, MESHING_STEP_PERFORMED ) - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, std::string, MODEL_PART_NAME ) - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, unsigned int, DOMAIN_LABEL ) - - - //boundary definition - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, int, RIGID_WALL ) - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, Condition::Pointer, MASTER_CONDITION ) - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, WeakPointerVector< Element >, MASTER_ELEMENTS ) - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, WeakPointerVector< Node<3> >, MASTER_NODES ) - - //condition variables - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, ConditionContainerType, CHILDREN_CONDITIONS) - - //modeler criteria - KRATOS_DEFINE_APPLICATION_VARIABLE( PFEM_BASE_APPLICATION, double, MEAN_ERROR ) - - - ///@} - -} - -#endif /* KRATOS_PFEM_BASE_APPLICATION_VARIABLES_H_INCLUDED */ diff --git a/applications/PfemFluidDynamicsApplication/CMakeLists.txt b/applications/PfemFluidDynamicsApplication/CMakeLists.txt index 8614bf309f14..67232d5ab400 100755 --- a/applications/PfemFluidDynamicsApplication/CMakeLists.txt +++ b/applications/PfemFluidDynamicsApplication/CMakeLists.txt @@ -3,12 +3,16 @@ set(CMAKE_INCLUDE_CURRENT_DIR ON) message("**** configuring KratosPfemFluidDynamicsApplication ****") include_directories( ${CMAKE_SOURCE_DIR}/kratos ) -include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/../PfemBaseApplication ) include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/../SolidMechanicsApplication ) +include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/../PfemApplication ) -if(NOT (${PFEM_BASE_APPLICATION} MATCHES "ON")) - message(SEND_ERROR "The Pfem Base Application must be compiled before this one. Set PFEM_BASE_APPLICATION=ON in the configure file.") -endif(NOT (${PFEM_BASE_APPLICATION} MATCHES "ON")) +if(NOT (${SOLID_MECHANICS_APPLICATION} MATCHES "ON")) + message(SEND_ERROR "The Solid Mechanics Application must be compiled before this one. Set SOLID_MECHANICS_APPLICATION=ON in the configure file.") +endif(NOT (${SOLID_MECHANICS_APPLICATION} MATCHES "ON")) + +if(NOT (${PFEM_APPLICATION} MATCHES "ON")) + message(SEND_ERROR "The Pfem Base Application must be compiled before this one. Set PFEM_APPLICATION=ON in the configure file.") +endif(NOT (${PFEM_APPLICATION} MATCHES "ON")) if(NOT DEFINED ${INCLUDE_TRIANGLE}) set(INCLUDE_TRIANGLE ON) @@ -46,7 +50,7 @@ set( KRATOS_PFEM_FLUID_DYNAMICS_APPLICATION_SOURCES ## define library Kratos which defines the basic python interface add_library(KratosPfemFluidDynamicsApplication SHARED ${KRATOS_PFEM_FLUID_DYNAMICS_APPLICATION_SOURCES}) #####***target_link_libraries(KratosPfemFluidDynamicsApplication KratosCore) -target_link_libraries(KratosPfemFluidDynamicsApplication KratosCore KratosSolidMechanicsApplication KratosPfemBaseApplication) +target_link_libraries(KratosPfemFluidDynamicsApplication KratosCore KratosSolidMechanicsApplication KratosPfemApplication) set_target_properties(KratosPfemFluidDynamicsApplication PROPERTIES PREFIX "") set_target_properties(KratosPfemFluidDynamicsApplication PROPERTIES COMPILE_DEFINITIONS "PFEM_FLUID_DYNAMICS_APPLICATION=EXPORT,API") install(TARGETS KratosPfemFluidDynamicsApplication DESTINATION libs ) diff --git a/applications/PfemFluidDynamicsApplication/custom_processes/model_start_end_meshing_for_fluids_process.hpp b/applications/PfemFluidDynamicsApplication/custom_processes/model_start_end_meshing_for_fluids_process.hpp index 0125b01a7e8a..aa8387e67c63 100644 --- a/applications/PfemFluidDynamicsApplication/custom_processes/model_start_end_meshing_for_fluids_process.hpp +++ b/applications/PfemFluidDynamicsApplication/custom_processes/model_start_end_meshing_for_fluids_process.hpp @@ -1,5 +1,5 @@ // -// Project Name: KratosPfemBaseApplication $ +// Project Name: KratosPfemApplication $ // Created by: $Author: JMCarbonell $ // Last modified by: $Co-Author: $ // Date: $Date: February 2016 $ diff --git a/applications/PfemFluidDynamicsApplication/pfem_fluid_dynamics_application.h b/applications/PfemFluidDynamicsApplication/pfem_fluid_dynamics_application.h index 5565bdbd4d04..93be0e837a72 100755 --- a/applications/PfemFluidDynamicsApplication/pfem_fluid_dynamics_application.h +++ b/applications/PfemFluidDynamicsApplication/pfem_fluid_dynamics_application.h @@ -31,7 +31,7 @@ // Core applications #include "solid_mechanics_application.h" -#include "pfem_base_application.h" +#include "pfem_application.h" //conditions diff --git a/applications/PfemFluidDynamicsApplication/pfem_fluid_dynamics_application_variables.h b/applications/PfemFluidDynamicsApplication/pfem_fluid_dynamics_application_variables.h index 420ec375dcb9..3b9708a34133 100644 --- a/applications/PfemFluidDynamicsApplication/pfem_fluid_dynamics_application_variables.h +++ b/applications/PfemFluidDynamicsApplication/pfem_fluid_dynamics_application_variables.h @@ -33,7 +33,7 @@ #include "includes/variables.h" #include "solid_mechanics_application_variables.h" -#include "pfem_base_application_variables.h" +#include "pfem_application_variables.h" namespace Kratos { diff --git a/applications/PfemFluidDynamicsApplication/python_scripts/KratosPfemFluid.py b/applications/PfemFluidDynamicsApplication/python_scripts/MainFluidPFEM.py similarity index 99% rename from applications/PfemFluidDynamicsApplication/python_scripts/KratosPfemFluid.py rename to applications/PfemFluidDynamicsApplication/python_scripts/MainFluidPFEM.py index 91d3932b6650..4e51886c9132 100644 --- a/applications/PfemFluidDynamicsApplication/python_scripts/KratosPfemFluid.py +++ b/applications/PfemFluidDynamicsApplication/python_scripts/MainFluidPFEM.py @@ -12,7 +12,7 @@ import KratosMultiphysics import KratosMultiphysics.SolidMechanicsApplication as KratosSolid import KratosMultiphysics.ExternalSolversApplication as KratosSolvers -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact import KratosMultiphysics.PfemSolidMechanicsApplication as KratosPfemSolid import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid diff --git a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_mesh_modeler.py b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_mesh_modeler.py index 0a70c42519e4..65efff57d87b 100644 --- a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_mesh_modeler.py +++ b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_mesh_modeler.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid # Check that KratosMultiphysics was imported in the main script @@ -23,16 +23,16 @@ def InitializeMeshing(self): # set execution flags: to set the options to be executed in methods and processes execution_options = KratosMultiphysics.Flags() - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, False) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, False) self.MeshingParameters.SetExecutionOptions(execution_options) @@ -85,16 +85,16 @@ def FinalizeMeshing(self): execution_options = KratosMultiphysics.Flags() # all flags - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, False) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, False) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, False) self.MeshingParameters.SetExecutionOptions(execution_options) diff --git a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_meshing_domain.py b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_meshing_domain.py index 455f6f1036bb..f93780cbe6aa 100644 --- a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_meshing_domain.py +++ b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_meshing_domain.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid import KratosMultiphysics.SolidMechanicsApplication as KratosSolid @@ -17,7 +17,7 @@ class FluidMeshingDomain(meshing_domain.MeshingDomain): def ComputeAverageMeshParameters(self): - ModelerUtils = KratosPfemBase.ModelerUtilities(); + ModelerUtils = KratosPfem.ModelerUtilities(); self.domain_volume = ModelerUtils.ComputeModelPartVolume(self.main_model_part) self.element_mean_volume = 0 diff --git a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_meshing_strategy.py b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_meshing_strategy.py index 97bea5442938..68418e6c889d 100644 --- a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_meshing_strategy.py +++ b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_meshing_strategy.py @@ -2,7 +2,7 @@ #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid # Check that KratosMultiphysics was imported in the main script diff --git a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_post_refining_modeler.py b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_post_refining_modeler.py index 3f041ee54c6a..fc6b20a0ce17 100644 --- a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_post_refining_modeler.py +++ b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_post_refining_modeler.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid # Check that KratosMultiphysics was imported in the main script @@ -46,34 +46,34 @@ def InitializeMeshing(self): execution_options = KratosMultiphysics.Flags() - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, True) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, True) self.MeshingParameters.SetExecutionOptions(execution_options) if( self.domain_size == 2 ): - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_ADD_NODES) ): + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_ADD_NODES) ): #"YYJaqrn" "YJq1.4arn" "Jq1.4arn" - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pYJq1.4arnCQ" else: modeler_flags = "YJq1.4arnQ" - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES) ): + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES) ): #"riYYJQ" "riYYJQ" "riJQ" "riQ" - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "rinYYJQ" else: #modeler_flags = "nJFMQO4/4" @@ -81,14 +81,14 @@ def InitializeMeshing(self): elif( self.domain_size == 3 ): - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_ADD_NODES) ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_ADD_NODES) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pMYJq1.4arnCBQF" else: modeler_flags = "YJq1.4arnBQF" - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES) ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "rinYYJBQF" else: # in PSolid "rQYYCCJFu0" @@ -120,23 +120,23 @@ def SetPostMeshingProcesses(self): print("::[fluid_post_refining_modeler]:: -START SetPostMeshingProcesses-") #select mesh elements - #generate_particles = KratosPfemBase.GenerateNewNodes(self.main_model_part, self.MeshingParameters, self.mesh_id, self.echo_level) + #generate_particles = KratosPfem.GenerateNewNodes(self.main_model_part, self.MeshingParameters, self.mesh_id, self.echo_level) #self.mesher.SetPostMeshingProcess(generate_particles) #select mesh elements - #select_mesh_elements = KratosPfemBase.SelectMeshElements(self.main_model_part, self.MeshingParameters, self.echo_level) + #select_mesh_elements = KratosPfem.SelectMeshElements(self.main_model_part, self.MeshingParameters, self.echo_level) #self.mesher.SetPostMeshingProcess(select_mesh_elements) select_mesh_elements = KratosPfemFluid.SelectMeshElementsForFluids(self.main_model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(select_mesh_elements) #rebuild elements - #rebuild_mesh_elements = KratosPfemBase.BuildMeshElements(self.main_model_part, self.MeshingParameters, self.mesh_id, self.echo_level) - rebuild_mesh_elements = KratosPfemBase.BuildMeshElements(self.main_model_part, self.MeshingParameters, self.echo_level) + #rebuild_mesh_elements = KratosPfem.BuildMeshElements(self.main_model_part, self.MeshingParameters, self.mesh_id, self.echo_level) + rebuild_mesh_elements = KratosPfem.BuildMeshElements(self.main_model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(rebuild_mesh_elements) #rebuild boundary - rebuild_mesh_boundary = KratosPfemBase.ReconstructMeshBoundary(self.main_model_part, self.MeshingParameters, self.echo_level) + rebuild_mesh_boundary = KratosPfem.ReconstructMeshBoundary(self.main_model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(rebuild_mesh_boundary) @@ -148,16 +148,16 @@ def FinalizeMeshing(self): execution_options = KratosMultiphysics.Flags() # all flags - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, True) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, True) self.MeshingParameters.SetExecutionOptions(execution_options) diff --git a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_pre_refining_modeler.py b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_pre_refining_modeler.py index 6868a3f4b30d..484a8aef39bd 100644 --- a/applications/PfemFluidDynamicsApplication/python_scripts/fluid_pre_refining_modeler.py +++ b/applications/PfemFluidDynamicsApplication/python_scripts/fluid_pre_refining_modeler.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 #import kratos core and applications import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid # Check that KratosMultiphysics was imported in the main script @@ -41,18 +41,18 @@ def InitializeMeshing(self): execution_options = KratosMultiphysics.Flags() - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_ELEMENTS_TO_MESHER, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, False) - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, True) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, True) self.MeshingParameters.SetExecutionOptions(execution_options) @@ -64,7 +64,7 @@ def InitializeMeshing(self): modeler_info = "Prepare domain for refinement" if( self.domain_size == 2 ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pnBYYQ" else: modeler_flags = "nQP" @@ -72,7 +72,7 @@ def InitializeMeshing(self): elif( self.domain_size == 3 ): - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): modeler_flags = "pnBJFMYYQ" else: #modeler_flags = "rQYYCCJF" @@ -104,7 +104,7 @@ def SetPreMeshingProcesses(self): remove_mesh_nodes = KratosPfemFluid.RemoveMeshNodesForFluids(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPreMeshingProcess(remove_mesh_nodes) - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES) ): + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES) ): generate_new_nodes = KratosPfemFluid.GenerateNewNodesBeforeMeshing(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPreMeshingProcess(generate_new_nodes) @@ -123,32 +123,32 @@ def SetPostMeshingProcesses(self): #select mesh elements select_mesh_elements = KratosPfemFluid.SelectMeshElementsForFluids(self.model_part, self.MeshingParameters, self.echo_level) - #select_mesh_elements = KratosPfemBase.SelectMeshElements(self.main_model_part, self.MeshingParameters, self.echo_level) + #select_mesh_elements = KratosPfem.SelectMeshElements(self.main_model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(select_mesh_elements) #rebuild elements - #rebuild_mesh_elements = KratosPfemBase.BuildMeshElements(self.main_model_part, self.MeshingParameters, self.mesh_id, self.echo_level) + #rebuild_mesh_elements = KratosPfem.BuildMeshElements(self.main_model_part, self.MeshingParameters, self.mesh_id, self.echo_level) #self.mesher.SetPostMeshingProcess(rebuild_mesh_elements) - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_ADD_NODES) ): - select_refine_elements = KratosPfemBase.SetElementsToRefineOnSize(self.model_part, self.MeshingParameters, self.echo_level) + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_ADD_NODES) ): + select_refine_elements = KratosPfem.SetElementsToRefineOnSize(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(select_refine_elements) #rebuild elements - #rebuild_mesh_elements = KratosPfemBase.BuildMeshElements(self.model_part, self.MeshingParameters, self.mesh_id, self.echo_level) - rebuild_mesh_elements = KratosPfemBase.BuildMeshElements(self.model_part, self.MeshingParameters, self.echo_level) + #rebuild_mesh_elements = KratosPfem.BuildMeshElements(self.model_part, self.MeshingParameters, self.mesh_id, self.echo_level) + rebuild_mesh_elements = KratosPfem.BuildMeshElements(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(rebuild_mesh_elements) #rebuild boundary - rebuild_mesh_boundary = KratosPfemBase.BuildMeshBoundary(self.model_part, self.MeshingParameters, self.echo_level) + rebuild_mesh_boundary = KratosPfem.BuildMeshBoundary(self.model_part, self.MeshingParameters, self.echo_level) self.mesher.SetPostMeshingProcess(rebuild_mesh_boundary) #inlet_management = KratosPfemFluid.InletManagement(self.model_part, self.MeshingParameters, self.echo_level) #self.mesher.SetPostMeshingProcess(inlet_management) - #if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES) ): + #if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES) ): #select_refine_elements = KratosPfemFluid.SetElementsToRefineOnSize(self.model_part, self.MeshingParameters, self.mesh_id, self.echo_level) #self.mesher.SetPostMeshingProcess(select_refine_elements) @@ -166,21 +166,21 @@ def FinalizeMeshing(self): execution_options = KratosMultiphysics.Flags() # set for the post_refining process - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_INSERT_NODES) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_INSERT_NODES) ): + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_NODES_TO_MESHER, True) meshing_options = self.MeshingParameters.GetOptions() - if( meshing_options.Is(KratosPfemBase.ModelerUtilities.CONSTRAINED) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) + if( meshing_options.Is(KratosPfem.ModelerUtilities.CONSTRAINED) ): + execution_options.Set(KratosPfem.ModelerUtilities.TRANSFER_KRATOS_FACES_TO_MESHER, True) - if( refining_options.Is(KratosPfemBase.ModelerUtilities.REFINE_ADD_NODES) ): - execution_options.Set(KratosPfemBase.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) + if( refining_options.Is(KratosPfem.ModelerUtilities.REFINE_ADD_NODES) ): + execution_options.Set(KratosPfem.ModelerUtilities.INITIALIZE_MESHER_INPUT, False) - execution_options.Set(KratosPfemBase.ModelerUtilities.FINALIZE_MESHER_INPUT, True) + execution_options.Set(KratosPfem.ModelerUtilities.FINALIZE_MESHER_INPUT, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) - execution_options.Set(KratosPfemBase.ModelerUtilities.KEEP_ISOLATED_NODES, True) + execution_options.Set(KratosPfem.ModelerUtilities.SELECT_TESSELLATION_ELEMENTS, True) + execution_options.Set(KratosPfem.ModelerUtilities.KEEP_ISOLATED_NODES, True) self.MeshingParameters.SetExecutionOptions(execution_options) diff --git a/applications/PfemFluidDynamicsApplication/python_scripts/pfem_check_and_prepare_model_process_fluid.py b/applications/PfemFluidDynamicsApplication/python_scripts/pfem_check_and_prepare_model_process_fluid.py index 8886393529a1..38199f3604e7 100644 --- a/applications/PfemFluidDynamicsApplication/python_scripts/pfem_check_and_prepare_model_process_fluid.py +++ b/applications/PfemFluidDynamicsApplication/python_scripts/pfem_check_and_prepare_model_process_fluid.py @@ -1,7 +1,7 @@ import KratosMultiphysics from KratosMultiphysics.ExternalSolversApplication import * #from KratosMultiphysics.SolidMechanicsApplication import * -from KratosMultiphysics.PfemBaseApplication import * +from KratosMultiphysics.PfemApplication import * import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid import KratosMultiphysics.SolidMechanicsApplication as KratosSolid #from KratosMultiphysics.PfemFluidDynamicsApplication import * diff --git a/applications/PfemFluidDynamicsApplication/python_scripts/pfem_fluid_modeler_python_utility.py b/applications/PfemFluidDynamicsApplication/python_scripts/pfem_fluid_modeler_python_utility.py index 2c2b20a3f906..959f47e2102a 100644 --- a/applications/PfemFluidDynamicsApplication/python_scripts/pfem_fluid_modeler_python_utility.py +++ b/applications/PfemFluidDynamicsApplication/python_scripts/pfem_fluid_modeler_python_utility.py @@ -2,7 +2,7 @@ # importing the Kratos Library import KratosMultiphysics from KratosMultiphysics.SolidMechanicsApplication import * -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid KratosMultiphysics.CheckForPreviousImport() @@ -80,7 +80,7 @@ def SearchNodeNeighbours(self): mesh_id = 0 # define search utility - nodal_neighbour_search = KratosPfemBase.NodalNeighboursSearch(self.model_part, self.echo_level, number_of_avg_elems, number_of_avg_nodes, mesh_id) + nodal_neighbour_search = KratosPfem.NodalNeighboursSearch(self.model_part, self.echo_level, number_of_avg_elems, number_of_avg_nodes, mesh_id) # execute search: nodal_neighbour_search.Execute() @@ -95,7 +95,7 @@ def SearchElementNeighbours(self): mesh_id = 0 # define search utility - elemental_neighbour_search = KratosPfemBase.ElementalNeighboursSearch(self.model_part, self.domain_size, self.echo_level, number_of_avg_elems, mesh_id) + elemental_neighbour_search = KratosPfem.ElementalNeighboursSearch(self.model_part, self.domain_size, self.echo_level, number_of_avg_elems, mesh_id) # execute search: elemental_neighbour_search.Execute() @@ -107,7 +107,7 @@ def ComputeBoundaryNormals(self): # define calculation utility # normals_calculation = BoundaryNormalsCalculation() - normals_calculation = KratosPfemBase.BoundaryNormalsCalculation() + normals_calculation = KratosPfem.BoundaryNormalsCalculation() # execute calculation: #(scaled normals) @@ -126,7 +126,7 @@ def BuildMeshBoundary(self): # define building utility # skin_build = BuildMeshBoundary(self.model_part, self.domain_size, self.echo_level, mesh_id) - skin_build = KratosPfemBase.BuildMeshBoundary(self.model_part, mesh_id, self.echo_level) + skin_build = KratosPfem.BuildMeshBoundary(self.model_part, mesh_id, self.echo_level) # execute building: skin_build.Execute() diff --git a/applications/PfemFluidDynamicsApplication/python_scripts/remesh_fluid_domains_process.py b/applications/PfemFluidDynamicsApplication/python_scripts/remesh_fluid_domains_process.py index 229de775c62e..b9a6f1ff8f37 100644 --- a/applications/PfemFluidDynamicsApplication/python_scripts/remesh_fluid_domains_process.py +++ b/applications/PfemFluidDynamicsApplication/python_scripts/remesh_fluid_domains_process.py @@ -1,7 +1,7 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library import KratosMultiphysics -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid KratosMultiphysics.CheckForPreviousImport() @@ -91,7 +91,7 @@ def ExecuteInitialize(self): self.meshing_output = self.meshing_frequency - self.main_model_part.ProcessInfo.SetValue(KratosPfemBase.INITIALIZED_DOMAINS, False); + self.main_model_part.ProcessInfo.SetValue(KratosPfem.INITIALIZED_DOMAINS, False); # initialize modeler if( self.remesh_domains_active ): @@ -126,7 +126,7 @@ def InitializeDomains(self): self.neighbour_search_performed = True # set modeler utilities - self.modeler_utils = KratosPfemBase.ModelerUtilities() + self.modeler_utils = KratosPfem.ModelerUtilities() # set the domain labels to conditions self.modeler_utils.SetModelPartNameToConditions(self.main_model_part) @@ -143,7 +143,7 @@ def InitializeDomains(self): # set the domain labels to nodes self.modeler_utils.SetModelPartNameToNodes(self.main_model_part) - self.main_model_part.ProcessInfo.SetValue(KratosPfemBase.INITIALIZED_DOMAINS, True) + self.main_model_part.ProcessInfo.SetValue(KratosPfem.INITIALIZED_DOMAINS, True) if(self.echo_level>1): print(self.main_model_part) @@ -155,7 +155,7 @@ def BuildMeshBoundaryForFluids(self): # define building utility model_part_name = self.settings["model_part_name"].GetString() - skin_build = KratosPfemBase.BuildModelPartBoundary(self.main_model_part, model_part_name, self.echo_level) + skin_build = KratosPfem.BuildModelPartBoundary(self.main_model_part, model_part_name, self.echo_level) # execute building: skin_build.Execute() @@ -362,12 +362,12 @@ def RemeshFluidDomains(self): print("::[Remesh_fluid_domains_process]:: MESH DOMAIN...", self.counter) meshing_options = KratosMultiphysics.Flags() - self.modeler_utils = KratosPfemBase.ModelerUtilities() + self.modeler_utils = KratosPfem.ModelerUtilities() meshing_options.Set(self.modeler_utils.KEEP_ISOLATED_NODES, True) - #self.model_meshing = KratosPfemBase.ModelMeshing(self.main_model_part, meshing_options, self.echo_level) + #self.model_meshing = KratosPfem.ModelMeshing(self.main_model_part, meshing_options, self.echo_level) self.model_meshing = KratosPfemFluid.ModelMeshingForFluids(self.main_model_part, meshing_options, self.echo_level) self.model_meshing.ExecuteInitialize() diff --git a/applications/PfemFluidDynamicsApplication/test_examples/MainThermalCoupling.py b/applications/PfemFluidDynamicsApplication/test_examples/MainThermalCoupling.py index 7f48e4fc6954..eec71c4ebc73 100644 --- a/applications/PfemFluidDynamicsApplication/test_examples/MainThermalCoupling.py +++ b/applications/PfemFluidDynamicsApplication/test_examples/MainThermalCoupling.py @@ -48,7 +48,7 @@ def GetParallelSize(): import KratosMultiphysics import KratosMultiphysics.SolidMechanicsApplication as KratosSolid import KratosMultiphysics.ExternalSolversApplication as KratosSolvers -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact import KratosMultiphysics.PfemSolidMechanicsApplication as KratosPfemSolid import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid diff --git a/applications/PfemSolidMechanicsApplication/CMakeLists.txt b/applications/PfemSolidMechanicsApplication/CMakeLists.txt index 3dcf220ea63f..7a485ea45ad6 100755 --- a/applications/PfemSolidMechanicsApplication/CMakeLists.txt +++ b/applications/PfemSolidMechanicsApplication/CMakeLists.txt @@ -4,7 +4,7 @@ message("**** configuring KratosPfemSolidMechanicsApplication ****") include_directories( ${CMAKE_SOURCE_DIR}/kratos ) include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/../SolidMechanicsApplication ) -include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/../PfemBaseApplication ) +include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/../PfemApplication ) include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/../ContactMechanicsApplication ) @@ -12,9 +12,9 @@ if(NOT (${SOLID_MECHANICS_APPLICATION} MATCHES "ON")) message(SEND_ERROR "The Solid Mechanics Application must be compiled before this one. Set SOLID_MECHANICS_APPLICATION=ON in the configure file.") endif(NOT (${SOLID_MECHANICS_APPLICATION} MATCHES "ON")) -if(NOT (${PFEM_BASE_APPLICATION} MATCHES "ON")) - message(SEND_ERROR "The Pfem Base Application must be compiled before this one. Set PFEM_BASE_APPLICATION=ON in the configure file.") -endif(NOT (${PFEM_BASE_APPLICATION} MATCHES "ON")) +if(NOT (${PFEM_APPLICATION} MATCHES "ON")) + message(SEND_ERROR "The Pfem Base Application must be compiled before this one. Set PFEM_APPLICATION=ON in the configure file.") +endif(NOT (${PFEM_APPLICATION} MATCHES "ON")) if(NOT (${CONTACT_MECHANICS_APPLICATION} MATCHES "ON")) message(SEND_ERROR "The Contact Mechanics Application must be compiled before this one. Set CONTACT_MECHANICS_APPLICATION=ON in the configure file.") diff --git a/applications/PfemSolidMechanicsApplication/custom_constitutive/hencky_plastic_3d_law.cpp b/applications/PfemSolidMechanicsApplication/custom_constitutive/hencky_plastic_3d_law.cpp index f4da9da2970d..9244024b3331 100644 --- a/applications/PfemSolidMechanicsApplication/custom_constitutive/hencky_plastic_3d_law.cpp +++ b/applications/PfemSolidMechanicsApplication/custom_constitutive/hencky_plastic_3d_law.cpp @@ -214,7 +214,7 @@ void HenckyElasticPlastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& //5.-Almansi Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { // e= 0.5*(1-invbT*invb) this->CalculateAlmansiStrain(ElasticVariables.CauchyGreenMatrix, StrainVector); diff --git a/applications/PfemSolidMechanicsApplication/custom_constitutive/non_linear_hencky_plastic_3D_law.cpp b/applications/PfemSolidMechanicsApplication/custom_constitutive/non_linear_hencky_plastic_3D_law.cpp index d4dc8534295f..8221dca7e7cd 100644 --- a/applications/PfemSolidMechanicsApplication/custom_constitutive/non_linear_hencky_plastic_3D_law.cpp +++ b/applications/PfemSolidMechanicsApplication/custom_constitutive/non_linear_hencky_plastic_3D_law.cpp @@ -149,7 +149,7 @@ void NonLinearHenckyElasticPlastic3DLaw::CalculateMaterialResponseKirchhoff (Par ElasticVariables.CauchyGreenMatrix = mElasticLeftCauchyGreen; //4.-Almansi Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { // e= 0.5*(1-invbT*invb) this->CalculateAlmansiStrain(ElasticVariables.CauchyGreenMatrix,StrainVector); @@ -185,7 +185,7 @@ void NonLinearHenckyElasticPlastic3DLaw::CalculateMaterialResponseKirchhoff (Par this->CalculateElastoPlasticTangentMatrix( ReturnMappingVariables, NewElasticLeftCauchyGreen, rAlpha, ElastoPlasticTangentMatrix, ElasticVariables); - //if( Options.Is(ConstitutiveLaw::TOTAL_TENSOR ) ) + ConstitutiveMatrix = this->SetConstitutiveMatrixToAppropiateDimension(ElastoPlasticTangentMatrix); } diff --git a/applications/PfemSolidMechanicsApplication/custom_elements/axisym_updated_lagrangian_U_J_wP_element.cpp b/applications/PfemSolidMechanicsApplication/custom_elements/axisym_updated_lagrangian_U_J_wP_element.cpp index a8fc9910b9d1..5b7307e0eb2c 100644 --- a/applications/PfemSolidMechanicsApplication/custom_elements/axisym_updated_lagrangian_U_J_wP_element.cpp +++ b/applications/PfemSolidMechanicsApplication/custom_elements/axisym_updated_lagrangian_U_J_wP_element.cpp @@ -203,7 +203,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints( mThisIntegrationMethod); diff --git a/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_P_element.cpp b/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_P_element.cpp index 695200486e5e..596e4683d92c 100644 --- a/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_P_element.cpp +++ b/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_P_element.cpp @@ -395,7 +395,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions = Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); // for integration points @@ -2006,7 +2006,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); diff --git a/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_element.cpp b/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_element.cpp index fa5a6dfd59bf..894fed848456 100644 --- a/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_element.cpp +++ b/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_element.cpp @@ -409,7 +409,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); unsigned int PointNumber = 0; @@ -514,7 +514,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); //reading integration points @@ -639,7 +639,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); //reading integration points @@ -1730,7 +1730,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); @@ -1815,7 +1815,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); diff --git a/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_wP_element.cpp b/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_wP_element.cpp index d8c453d14552..7128e635b254 100644 --- a/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_wP_element.cpp +++ b/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_J_wP_element.cpp @@ -392,7 +392,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); //reading integration points @@ -1274,7 +1274,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); @@ -1349,7 +1349,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); diff --git a/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_P_Second_element.cpp b/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_P_Second_element.cpp index 2bd7762d95b9..8c2a9065ff3f 100644 --- a/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_P_Second_element.cpp +++ b/applications/PfemSolidMechanicsApplication/custom_elements/updated_lagrangian_U_P_Second_element.cpp @@ -220,7 +220,7 @@ namespace Kratos //set constitutive law flags: Flags &ConstitutiveLawOptions = Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); // for integration points diff --git a/applications/PfemSolidMechanicsApplication/custom_kratos/CMakeLists.txt b/applications/PfemSolidMechanicsApplication/custom_kratos/CMakeLists.txt index 2a74864f30e2..e04c465f0b6e 100644 --- a/applications/PfemSolidMechanicsApplication/custom_kratos/CMakeLists.txt +++ b/applications/PfemSolidMechanicsApplication/custom_kratos/CMakeLists.txt @@ -12,7 +12,7 @@ message("CONVECTION_DIFFUSION_APPLICATION.... ${CONVECTION_DIFFUSION_APPLICATION message("MACHINING_APPLICATION............... ${MACHINING_APPLICATION}") message("STRING_DYNAMICS_APPLICATION......... ${STRING_DYNAMICS_APPLICATION}") message("SOLID_MECHANICS_APPLICATION......... ${SOLID_MECHANICS_APPLICATION}") -message("PFEM_BASE_APPLICATION............... ${PFEM_BASE_APPLICATION}") +message("PFEM_APPLICATION............... ${PFEM_APPLICATION}") message("PFEM_SOLID_MECHANICS_APPLICATION.... ${PFEM_SOLID_MECHANICS_APPLICATION}") message("FLUID_DYNAMICS_APPLICATION.......... ${FLUID_DYNAMICS_APPLICATION}") message("PFEM_FLUID_DYNAMICS_APPLICATION......${PFEM_FLUID_DYNAMICS_APPLICATION}") @@ -163,9 +163,9 @@ if(${SOLID_MECHANICS_APPLICATION} MATCHES ON) add_subdirectory(SolidMechanicsApplication) endif(${SOLID_MECHANICS_APPLICATION} MATCHES ON) -if(${PFEM_BASE_APPLICATION} MATCHES ON) - add_subdirectory(PfemBaseApplication) -endif(${PFEM_BASE_APPLICATION} MATCHES ON) +if(${PFEM_APPLICATION} MATCHES ON) + add_subdirectory(PfemApplication) +endif(${PFEM_APPLICATION} MATCHES ON) if(${PFEM_SOLID_MECHANICS_APPLICATION} MATCHES ON) add_subdirectory(PfemSolidMechanicsApplication) diff --git a/applications/PfemSolidMechanicsApplication/custom_kratos/applications_interface.py b/applications/PfemSolidMechanicsApplication/custom_kratos/applications_interface.py index e6801b1b505d..b1c55d8cd2db 100644 --- a/applications/PfemSolidMechanicsApplication/custom_kratos/applications_interface.py +++ b/applications/PfemSolidMechanicsApplication/custom_kratos/applications_interface.py @@ -5,7 +5,7 @@ Import_MachiningApplication = False Import_StringDynamicsApplication = False Import_SolidMechanicsApplication = False -Import_PfemBaseApplication = False +Import_PfemApplication = False Import_PfemSolidMechanicsApplication = False Import_PfemFluidDynamicsApplication = False Import_ALEApplication = False @@ -43,7 +43,7 @@ print("Import_MachiningApplication: False") print("Import_StringDynamicsApplication: False") print("Import_SolidMechanicsApplication: False") -print("Import_PfemBaseApplication: False") +print("Import_PfemApplication: False") print("Import_PfemSolidMechanicsApplication: False") print("Import_PfemFluidDynamicsApplication: False") print("Import_ALEApplication: False") @@ -88,7 +88,7 @@ def ImportApplications(kernel, applications_path=application_directory): print("Import_MachiningApplication: " + str(Import_MachiningApplication)) print("Import_StringDynamicsApplication: " + str(Import_StringDynamicsApplication)) print("Import_SolidMechanicsApplication: " + str(Import_SolidMechanicsApplication)) - print("Import_PfemBaseApplication: " + str(Import_PfemBaseApplication)) + print("Import_PfemApplication: " + str(Import_PfemApplication)) print("Import_PfemSolidMechanicsApplication: " + str(Import_PfemSolidMechanicsApplication)) print("Import_PfemFluidDynamicsApplication: " + str(Import_PfemFluidDynamicsApplication)) print("Import_ALEApplication: " + str(Import_ALEApplication)) @@ -148,14 +148,14 @@ def ImportApplications(kernel, applications_path=application_directory): kernel.AddApplication(solid_mechanics_application) print("KratosSolidMechanicsApplication Succesfully imported") - if(Import_PfemBaseApplication): - print("importing KratosPfemBaseApplication ...") - sys.path.append(applications_path + '/PfemBaseApplication/python_scripts') - sys.path.append(applications_path + '/PfemBaseApplication/Linux') - from KratosPfemBaseApplication import * - solid_mechanics_application = KratosPfemBaseApplication() - kernel.AddApplication(pfem_base_application) - print("KratosPfemBaseApplication Succesfully imported") + if(Import_PfemApplication): + print("importing KratosPfemApplication ...") + sys.path.append(applications_path + '/PfemApplication/python_scripts') + sys.path.append(applications_path + '/PfemApplication/Linux') + from KratosPfemApplication import * + solid_mechanics_application = KratosPfemApplication() + kernel.AddApplication(pfem_application) + print("KratosPfemApplication Succesfully imported") if(Import_PfemSolidMechanicsApplication): print("importing KratosPfemSolidMechanicsApplication ...") @@ -432,8 +432,8 @@ def ImportApplications(kernel, applications_path=application_directory): kernel.Initialize() if(Import_SolidMechanicsApplication): kernel.InitializeApplication(solid_mechanics_application) - if(Import_PfemBaseApplication): - kernel.InitializeApplication(pfem_base_application) + if(Import_PfemApplication): + kernel.InitializeApplication(pfem_application) if(Import_PfemSolidMechanicsApplication): kernel.InitializeApplication(pfem_solid_mechanics_application) if(Import_PfemFluidDynamicsApplication): diff --git a/applications/PfemSolidMechanicsApplication/custom_problemtype/Kratos_Pfem_Solid_Mechanics_Application.gid/003_Kratos_Pfem_Solid_Mechanics_Application_var.json.bas b/applications/PfemSolidMechanicsApplication/custom_problemtype/Kratos_Pfem_Solid_Mechanics_Application.gid/003_Kratos_Pfem_Solid_Mechanics_Application_var.json.bas index 52f9c5caa141..c0c38ba10e41 100644 --- a/applications/PfemSolidMechanicsApplication/custom_problemtype/Kratos_Pfem_Solid_Mechanics_Application.gid/003_Kratos_Pfem_Solid_Mechanics_Application_var.json.bas +++ b/applications/PfemSolidMechanicsApplication/custom_problemtype/Kratos_Pfem_Solid_Mechanics_Application.gid/003_Kratos_Pfem_Solid_Mechanics_Application_var.json.bas @@ -140,7 +140,7 @@ }, "problem_process_list" : [{ "help" : "This process applies meshing to the problem domains", - "kratos_module" : "KratosMultiphysics.PfemBaseApplication", + "kratos_module" : "KratosMultiphysics.PfemApplication", "python_module" : "remesh_domains_process", "process_name" : "RemeshDomainsProcess", "Parameters" : { diff --git a/applications/PfemSolidMechanicsApplication/custom_problemtype/Kratos_Pfem_Solid_Mechanics_Application.gid/script.py b/applications/PfemSolidMechanicsApplication/custom_problemtype/Kratos_Pfem_Solid_Mechanics_Application.gid/script.py index cec478c9a8c9..3fe937425781 100755 --- a/applications/PfemSolidMechanicsApplication/custom_problemtype/Kratos_Pfem_Solid_Mechanics_Application.gid/script.py +++ b/applications/PfemSolidMechanicsApplication/custom_problemtype/Kratos_Pfem_Solid_Mechanics_Application.gid/script.py @@ -48,7 +48,7 @@ def GetParallelSize(): import KratosMultiphysics import KratosMultiphysics.SolidMechanicsApplication as KratosSolid import KratosMultiphysics.ExternalSolversApplication as KratosSolvers -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact import KratosMultiphysics.PfemSolidMechanicsApplication as KratosPfemSolid import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid diff --git a/applications/PfemSolidMechanicsApplication/python_scripts/KratosPfemSolid.py b/applications/PfemSolidMechanicsApplication/python_scripts/KratosPfemSolid.py index 9bbc23369e89..5217d4e56e72 100644 --- a/applications/PfemSolidMechanicsApplication/python_scripts/KratosPfemSolid.py +++ b/applications/PfemSolidMechanicsApplication/python_scripts/KratosPfemSolid.py @@ -48,7 +48,7 @@ def GetParallelSize(): import KratosMultiphysics import KratosMultiphysics.SolidMechanicsApplication as KratosSolid import KratosMultiphysics.ExternalSolversApplication as KratosSolvers -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact import KratosMultiphysics.PfemSolidMechanicsApplication as KratosPfemSolid diff --git a/applications/PfemSolidMechanicsApplication/python_scripts/pfem_solid_variables.py b/applications/PfemSolidMechanicsApplication/python_scripts/pfem_solid_variables.py index 36cd65ca9530..ec7a45af90cf 100644 --- a/applications/PfemSolidMechanicsApplication/python_scripts/pfem_solid_variables.py +++ b/applications/PfemSolidMechanicsApplication/python_scripts/pfem_solid_variables.py @@ -3,7 +3,7 @@ #import kratos core and applications import KratosMultiphysics import KratosMultiphysics.SolidMechanicsApplication as KratosSolid -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact import KratosMultiphysics.PfemSolidMechanicsApplication as KratosPfemSolid @@ -19,10 +19,10 @@ def AddVariables(main_model_part): main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.CONTACT_FORCE) main_model_part.AddNodalSolutionStepVariable(KratosMultiphysics.CONTACT_NORMAL); - main_model_part.AddNodalSolutionStepVariable(KratosPfemBase.OFFSET); - main_model_part.AddNodalSolutionStepVariable(KratosPfemBase.SHRINK_FACTOR); - main_model_part.AddNodalSolutionStepVariable(KratosPfemBase.MEAN_ERROR); - main_model_part.AddNodalSolutionStepVariable(KratosPfemBase.RIGID_WALL); + main_model_part.AddNodalSolutionStepVariable(KratosPfem.OFFSET); + main_model_part.AddNodalSolutionStepVariable(KratosPfem.SHRINK_FACTOR); + main_model_part.AddNodalSolutionStepVariable(KratosPfem.MEAN_ERROR); + main_model_part.AddNodalSolutionStepVariable(KratosPfem.RIGID_WALL); main_model_part.AddNodalSolutionStepVariable(KratosContact.CONTACT_STRESS); main_model_part.AddNodalSolutionStepVariable(KratosContact.EFFECTIVE_CONTACT_STRESS); diff --git a/applications/PoromechanicsApplication/custom_constitutive/nonlocal_damage_3D_law.cpp b/applications/PoromechanicsApplication/custom_constitutive/nonlocal_damage_3D_law.cpp index b21efe81c02b..8f42d016df99 100644 --- a/applications/PoromechanicsApplication/custom_constitutive/nonlocal_damage_3D_law.cpp +++ b/applications/PoromechanicsApplication/custom_constitutive/nonlocal_damage_3D_law.cpp @@ -98,7 +98,7 @@ void NonlocalDamage3DLaw::CalculateMaterialResponseCauchy (Parameters& rValues) // CharacteristicSize (for nonlocal damage it must be 1.0) ReturnMappingVariables.CharacteristicSize = 1.0; - if(Options.Is(ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY)) // LOCAL QUANTITIES + if(Options.Is(ConstitutiveLaw::INITIALIZE_MATERIAL_RESPONSE)) // LOCAL QUANTITIES { if(Options.Is(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR)) { diff --git a/applications/PoromechanicsApplication/custom_elements/U_Pw_small_strain_FIC_element.cpp b/applications/PoromechanicsApplication/custom_elements/U_Pw_small_strain_FIC_element.cpp index 07f39f7abe91..b686a6fc7f62 100644 --- a/applications/PoromechanicsApplication/custom_elements/U_Pw_small_strain_FIC_element.cpp +++ b/applications/PoromechanicsApplication/custom_elements/U_Pw_small_strain_FIC_element.cpp @@ -88,7 +88,7 @@ void UPwSmallStrainFICElement::InitializeNonLinearIteration(Proc double detF = 1.0; ConstitutiveLaw::Parameters ConstitutiveParameters(Geom,this->GetProperties(),rCurrentProcessInfo); ConstitutiveParameters.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); - ConstitutiveParameters.Set(ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY); //Note: this is for nonlocal damage + ConstitutiveParameters.Set(ConstitutiveLaw::INITIALIZE_MATERIAL_RESPONSE); //Note: this is for nonlocal damage ConstitutiveParameters.SetConstitutiveMatrix(ConstitutiveMatrix); ConstitutiveParameters.SetStressVector(StressVector); ConstitutiveParameters.SetStrainVector(StrainVector); @@ -158,7 +158,7 @@ void UPwSmallStrainFICElement::FinalizeNonLinearIteration(Proces double detF = 1.0; ConstitutiveLaw::Parameters ConstitutiveParameters(Geom,this->GetProperties(),rCurrentProcessInfo); ConstitutiveParameters.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); - ConstitutiveParameters.Set(ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY); //Note: this is for nonlocal damage + ConstitutiveParameters.Set(ConstitutiveLaw::INITIALIZE_MATERIAL_RESPONSE); //Note: this is for nonlocal damage ConstitutiveParameters.SetConstitutiveMatrix(ConstitutiveMatrix); ConstitutiveParameters.SetStressVector(StressVector); ConstitutiveParameters.SetStrainVector(StrainVector); diff --git a/applications/PoromechanicsApplication/custom_elements/U_Pw_small_strain_element.cpp b/applications/PoromechanicsApplication/custom_elements/U_Pw_small_strain_element.cpp index b2908b207e35..feb36cdb9914 100644 --- a/applications/PoromechanicsApplication/custom_elements/U_Pw_small_strain_element.cpp +++ b/applications/PoromechanicsApplication/custom_elements/U_Pw_small_strain_element.cpp @@ -120,7 +120,7 @@ void UPwSmallStrainElement::InitializeNonLinearIteration(Process double detF = 1.0; ConstitutiveLaw::Parameters ConstitutiveParameters(Geom,this->GetProperties(),rCurrentProcessInfo); ConstitutiveParameters.Set(ConstitutiveLaw::COMPUTE_STRESS); - ConstitutiveParameters.Set(ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY); //Note: this is for nonlocal damage + ConstitutiveParameters.Set(ConstitutiveLaw::INITIALIZE_MATERIAL_RESPONSE); //Note: this is for nonlocal damage ConstitutiveParameters.SetConstitutiveMatrix(ConstitutiveMatrix); ConstitutiveParameters.SetStressVector(StressVector); ConstitutiveParameters.SetStrainVector(StrainVector); diff --git a/applications/ShapeOptimizationApplication/CMakeLists.txt b/applications/ShapeOptimizationApplication/CMakeLists.txt index 2c071ae61f45..de048580841f 100644 --- a/applications/ShapeOptimizationApplication/CMakeLists.txt +++ b/applications/ShapeOptimizationApplication/CMakeLists.txt @@ -5,7 +5,7 @@ message("**** configuring KratosShapeOptimizationApplication ****") include_directories( ${CMAKE_SOURCE_DIR}/kratos ) #dependecies on other applications -include_directories( ${CMAKE_SOURCE_DIR}/applications/SolidMechanicsApplication ) +include_directories( ${CMAKE_SOURCE_DIR}/applications/StructuralMechanicsApplication ) ## generate variables with the sources set( KRATOS_SHAPEOPTIMIZATION_APPLICATION_SOURCES @@ -19,7 +19,7 @@ set( KRATOS_SHAPEOPTIMIZATION_APPLICATION_SOURCES ############################################################### ## define library Kratos which defines the basic python interface add_library(KratosShapeOptimizationApplication SHARED ${KRATOS_SHAPEOPTIMIZATION_APPLICATION_SOURCES}) -target_link_libraries(KratosShapeOptimizationApplication KratosCore KratosSolidMechanicsApplication) +target_link_libraries(KratosShapeOptimizationApplication KratosCore KratosStructuralMechanicsApplication) set_target_properties(KratosShapeOptimizationApplication PROPERTIES PREFIX "") install(TARGETS KratosShapeOptimizationApplication DESTINATION libs ) diff --git a/applications/ShapeOptimizationApplication/ShapeOptimizationApplication.py b/applications/ShapeOptimizationApplication/ShapeOptimizationApplication.py index 17143fb08985..880dfb0336f8 100644 --- a/applications/ShapeOptimizationApplication/ShapeOptimizationApplication.py +++ b/applications/ShapeOptimizationApplication/ShapeOptimizationApplication.py @@ -4,7 +4,7 @@ # License: BSD License # license: ShapeOptimizationApplication/license.txt # -# Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +# Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner # # ============================================================================== diff --git a/applications/ShapeOptimizationApplication/custom_conditions/shape_optimization_condition.cpp b/applications/ShapeOptimizationApplication/custom_conditions/shape_optimization_condition.cpp index e7ec1bbf7aa7..1bf0fc41079a 100644 --- a/applications/ShapeOptimizationApplication/custom_conditions/shape_optimization_condition.cpp +++ b/applications/ShapeOptimizationApplication/custom_conditions/shape_optimization_condition.cpp @@ -4,7 +4,7 @@ // License: BSD License // license: ShapeOptimizationApplication/license.txt // -// Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +// Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner // // ============================================================================== diff --git a/applications/ShapeOptimizationApplication/custom_conditions/shape_optimization_condition.h b/applications/ShapeOptimizationApplication/custom_conditions/shape_optimization_condition.h index b6820f8db6c2..873aead8fa31 100644 --- a/applications/ShapeOptimizationApplication/custom_conditions/shape_optimization_condition.h +++ b/applications/ShapeOptimizationApplication/custom_conditions/shape_optimization_condition.h @@ -4,7 +4,7 @@ // License: BSD License // license: ShapeOptimizationApplication/license.txt // -// Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +// Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner // // ============================================================================== diff --git a/applications/ShapeOptimizationApplication/custom_elements/small_displacement_analytic_sensitivity_element.cpp b/applications/ShapeOptimizationApplication/custom_elements/small_displacement_analytic_sensitivity_element.cpp index 96f8e2f65551..ac3c0613e57c 100755 --- a/applications/ShapeOptimizationApplication/custom_elements/small_displacement_analytic_sensitivity_element.cpp +++ b/applications/ShapeOptimizationApplication/custom_elements/small_displacement_analytic_sensitivity_element.cpp @@ -4,7 +4,7 @@ // License: BSD License // license: ShapeOptimizationApplication/license.txt // -// Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +// Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner // Geiser Armin, https://github.com/armingeiser // // ============================================================================== @@ -21,7 +21,7 @@ namespace Kratos // ============================================================================================================================================= SmallDisplacementAnalyticSensitivityElement::SmallDisplacementAnalyticSensitivityElement( IndexType NewId, GeometryType::Pointer pGeometry ) -: SmallDisplacementElement( NewId, pGeometry ) +: SmallDisplacement( NewId, pGeometry ) { //DO NOT ADD DOFS HERE!!! } @@ -32,9 +32,8 @@ SmallDisplacementAnalyticSensitivityElement::SmallDisplacementAnalyticSensitivit // ============================================================================================================================================= SmallDisplacementAnalyticSensitivityElement::SmallDisplacementAnalyticSensitivityElement( IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties ) -: SmallDisplacementElement( NewId, pGeometry, pProperties ) +: SmallDisplacement( NewId, pGeometry, pProperties ) { - mThisIntegrationMethod = GetGeometry().GetDefaultIntegrationMethod(); } @@ -43,7 +42,7 @@ SmallDisplacementAnalyticSensitivityElement::SmallDisplacementAnalyticSensitivit // ============================================================================================================================================= SmallDisplacementAnalyticSensitivityElement::SmallDisplacementAnalyticSensitivityElement( SmallDisplacementAnalyticSensitivityElement const& rOther) -:SmallDisplacementElement(rOther) +:SmallDisplacement(rOther) { } @@ -69,8 +68,6 @@ Element::Pointer SmallDisplacementAnalyticSensitivityElement::Clone( IndexType N //-----------// - NewElement.mThisIntegrationMethod = mThisIntegrationMethod; - if ( NewElement.mConstitutiveLawVector.size() != mConstitutiveLawVector.size() ) { NewElement.mConstitutiveLawVector.resize(mConstitutiveLawVector.size()); @@ -105,69 +102,72 @@ void SmallDisplacementAnalyticSensitivityElement::Calculate(const VariableGetStrainSize(); Vector result_x = ZeroVector(number_of_dofs); Vector result_y = ZeroVector(number_of_dofs); Vector result_z = ZeroVector(number_of_dofs); - //create and initialize element variables: - GeneralVariables Variables; - this->InitializeGeneralVariables(Variables,rCurrentProcessInfo); - - //create constitutive law parameters: - ConstitutiveLaw::Parameters Values(GetGeometry(),GetProperties(),rCurrentProcessInfo); - - //set constitutive law flags: - Flags &ConstitutiveLawOptions=Values.GetOptions(); - - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); - - //reading integration points - const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints( mThisIntegrationMethod ); - - //auxiliary terms - Vector VolumeForce = ZeroVector(dimension); - + KinematicVariables this_kinematic_variables(strain_size, dimension, number_of_nodes); + ConstitutiveVariables this_constitutive_variables(strain_size); + + // Reading integration points and local gradients + const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints( ); + + ConstitutiveLaw::Parameters Values(GetGeometry(),GetProperties(),rCurrentProcessInfo); + + // Set constitutive law flags: + Flags& ConstitutiveLawOptions=Values.GetOptions(); + ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, true); + + // Displacements vector + Vector displacements; + GetValuesVector(displacements); + + // Contribution to external forces + const Vector body_force = this->GetBodyForce(); + //ask for node for which DKDXU shall be computed int active_node_index = this->GetValue(ACTIVE_NODE_INDEX); - for ( unsigned int PointNumber = 0; PointNumber < integration_points.size(); PointNumber++ ) - { - //compute element kinematics B, F, DN_DX ... - this->CalculateKinematics(Variables,PointNumber); + for ( unsigned int point_number = 0; point_number < integration_points.size(); point_number++ ) + { + // Compute element kinematics B, F, DN_DX ... + CalculateKinematicVariables(this_kinematic_variables, point_number, integration_points); - //set general variables to constitutive law parameters - this->SetGeneralVariables(Variables,Values,PointNumber); + // Compute material reponse + CalculateConstitutiveVariables(this_kinematic_variables, this_constitutive_variables, Values, point_number, integration_points, GetStressMeasure(), displacements); - //compute stresses and constitutive parameters - mConstitutiveLawVector[PointNumber]->CalculateMaterialResponseCauchy(Values); + // Calculating weights for integration on the reference configuration + double IntegrationWeight = GetIntegrationWeight(integration_points, point_number, this_kinematic_variables.detJ0); - //calculating weights for integration on the "reference configuration" - double IntegrationWeight = integration_points[PointNumber].Weight() * Variables.detJ; - IntegrationWeight = this->CalculateIntegrationWeight( IntegrationWeight ); + if ( dimension == 2 && GetProperties().Has( THICKNESS )) + { + IntegrationWeight *= GetProperties()[THICKNESS]; + } // Computation of X-component of DKDXU - Matrix DB_DX = ZeroMatrix(Variables.B.size1(),Variables.B.size2()); - this->CalculateDerivedDeformationMatrix(DB_DX,Variables.DN_DX,active_node_index,0); - result_x += IntegrationWeight*prod( trans( DB_DX ), Vector(prod(Variables.ConstitutiveMatrix ,Vector(prod(Variables.B, rU)))) ); - result_x += IntegrationWeight*prod( trans( Variables.B ), Vector(prod(Variables.ConstitutiveMatrix ,Vector(prod(DB_DX, rU)))) ); - result_x += IntegrationWeight*prod( trans( Variables.B ), Vector(prod(Variables.ConstitutiveMatrix ,Vector(prod(Variables.B, rU)))) )*Variables.DN_DX(active_node_index,0); + Matrix DB_DX = ZeroMatrix(this_kinematic_variables.B.size1(),this_kinematic_variables.B.size2()); + this->CalculateDerivedDeformationMatrix(DB_DX,this_kinematic_variables.DN_DX,active_node_index,0); + result_x += IntegrationWeight*prod( trans( DB_DX ), Vector(prod(this_constitutive_variables.D ,Vector(prod(this_kinematic_variables.B, rU)))) ); + result_x += IntegrationWeight*prod( trans( this_kinematic_variables.B ), Vector(prod(this_constitutive_variables.D ,Vector(prod(DB_DX, rU)))) ); + result_x += IntegrationWeight*prod( trans( this_kinematic_variables.B ), Vector(prod(this_constitutive_variables.D ,Vector(prod(this_kinematic_variables.B, rU)))) )*this_kinematic_variables.DN_DX(active_node_index,0); this->SetValue(DKDXU_X,result_x); // Computation of Y-component of DKDXU DB_DX.clear(); - this->CalculateDerivedDeformationMatrix(DB_DX,Variables.DN_DX,active_node_index,1); - result_y += IntegrationWeight*prod( trans( DB_DX ), Vector(prod(Variables.ConstitutiveMatrix ,Vector(prod(Variables.B, rU)))) ); - result_y += IntegrationWeight*prod( trans( Variables.B ), Vector(prod(Variables.ConstitutiveMatrix ,Vector(prod(DB_DX, rU)))) ); - result_y += IntegrationWeight*prod( trans( Variables.B ), Vector(prod(Variables.ConstitutiveMatrix ,Vector(prod(Variables.B, rU)))) )*Variables.DN_DX(active_node_index,1); + this->CalculateDerivedDeformationMatrix(DB_DX,this_kinematic_variables.DN_DX,active_node_index,1); + result_y += IntegrationWeight*prod( trans( DB_DX ), Vector(prod(this_constitutive_variables.D ,Vector(prod(this_kinematic_variables.B, rU)))) ); + result_y += IntegrationWeight*prod( trans( this_kinematic_variables.B ), Vector(prod(this_constitutive_variables.D ,Vector(prod(DB_DX, rU)))) ); + result_y += IntegrationWeight*prod( trans( this_kinematic_variables.B ), Vector(prod(this_constitutive_variables.D ,Vector(prod(this_kinematic_variables.B, rU)))) )*this_kinematic_variables.DN_DX(active_node_index,1); this->SetValue(DKDXU_Y,result_y); // Computation of Z-component of DKDXU DB_DX.clear(); - this->CalculateDerivedDeformationMatrix(DB_DX,Variables.DN_DX,active_node_index,2); - result_z += IntegrationWeight*prod( trans( DB_DX ), Vector(prod(Variables.ConstitutiveMatrix ,Vector(prod(Variables.B, rU)))) ); - result_z += IntegrationWeight*prod( trans( Variables.B ), Vector(prod(Variables.ConstitutiveMatrix ,Vector(prod(DB_DX, rU)))) ); - result_z += IntegrationWeight*prod( trans( Variables.B ), Vector(prod(Variables.ConstitutiveMatrix ,Vector(prod(Variables.B, rU)))) )*Variables.DN_DX(active_node_index,2); + this->CalculateDerivedDeformationMatrix(DB_DX,this_kinematic_variables.DN_DX,active_node_index,2); + result_z += IntegrationWeight*prod( trans( DB_DX ), Vector(prod(this_constitutive_variables.D ,Vector(prod(this_kinematic_variables.B, rU)))) ); + result_z += IntegrationWeight*prod( trans( this_kinematic_variables.B ), Vector(prod(this_constitutive_variables.D ,Vector(prod(DB_DX, rU)))) ); + result_z += IntegrationWeight*prod( trans( this_kinematic_variables.B ), Vector(prod(this_constitutive_variables.D ,Vector(prod(this_kinematic_variables.B, rU)))) )*this_kinematic_variables.DN_DX(active_node_index,2); this->SetValue(DKDXU_Z,result_z); } } @@ -181,12 +181,12 @@ void SmallDisplacementAnalyticSensitivityElement::Calculate(const Variable The following damping regions are defined: \n") - for regionNumber in range(self.optimizationSettings["design_variables"]["damping"]["damping_regions"].size()): - regionName = self.optimizationSettings["design_variables"]["damping"]["damping_regions"][regionNumber]["sub_model_part_name"].GetString() - if self.inputModelPart.HasSubModelPart(regionName): - print(regionName) - dampingRegions[regionName] = self.inputModelPart.GetSubModelPart(regionName) - else: - raise ValueError("The following sub-model part specified for damping does not exist: ",regionName) - print("") + if(self.optimizationSettings["design_variables"]["damping"]["perform_damping"].GetBool()): + print("> The following damping regions are defined: \n") + for regionNumber in range(self.optimizationSettings["design_variables"]["damping"]["damping_regions"].size()): + regionName = self.optimizationSettings["design_variables"]["damping"]["damping_regions"][regionNumber]["sub_model_part_name"].GetString() + if self.inputModelPart.HasSubModelPart(regionName): + print(regionName) + dampingRegions[regionName] = self.inputModelPart.GetSubModelPart(regionName) + else: + raise ValueError("The following sub-model part specified for damping does not exist: ",regionName) + print("") return dampingRegions # ============================================================================== \ No newline at end of file diff --git a/applications/ShapeOptimizationApplication/python_scripts/response_function_factory.py b/applications/ShapeOptimizationApplication/python_scripts/response_function_factory.py index 14c17812585e..d0a45193399b 100644 --- a/applications/ShapeOptimizationApplication/python_scripts/response_function_factory.py +++ b/applications/ShapeOptimizationApplication/python_scripts/response_function_factory.py @@ -4,7 +4,7 @@ # License: BSD License # license: ShapeOptimizationApplication/license.txt # -# Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +# Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner # Geiser Armin, https://github.com/armingeiser # # ============================================================================== diff --git a/applications/ShapeOptimizationApplication/python_scripts/response_logger_base.py b/applications/ShapeOptimizationApplication/python_scripts/response_logger_base.py index 1946c5e0eca7..13a4543c2b74 100644 --- a/applications/ShapeOptimizationApplication/python_scripts/response_logger_base.py +++ b/applications/ShapeOptimizationApplication/python_scripts/response_logger_base.py @@ -4,7 +4,7 @@ # License: BSD License # license: ShapeOptimizationApplication/license.txt # -# Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +# Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner # Geiser Armin, https://github.com/armingeiser # # ============================================================================== diff --git a/applications/ShapeOptimizationApplication/python_scripts/response_logger_penalized_projection.py b/applications/ShapeOptimizationApplication/python_scripts/response_logger_penalized_projection.py index 6e7182ab503f..e53d679b24c0 100644 --- a/applications/ShapeOptimizationApplication/python_scripts/response_logger_penalized_projection.py +++ b/applications/ShapeOptimizationApplication/python_scripts/response_logger_penalized_projection.py @@ -4,7 +4,7 @@ # License: BSD License # license: ShapeOptimizationApplication/license.txt # -# Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +# Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner # Geiser Armin, https://github.com/armingeiser # # ============================================================================== diff --git a/applications/ShapeOptimizationApplication/python_scripts/response_logger_steepest_descent.py b/applications/ShapeOptimizationApplication/python_scripts/response_logger_steepest_descent.py index a3c845152188..b10fadb33bf5 100644 --- a/applications/ShapeOptimizationApplication/python_scripts/response_logger_steepest_descent.py +++ b/applications/ShapeOptimizationApplication/python_scripts/response_logger_steepest_descent.py @@ -4,7 +4,7 @@ # License: BSD License # license: ShapeOptimizationApplication/license.txt # -# Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +# Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner # Geiser Armin, https://github.com/armingeiser # # ============================================================================== diff --git a/applications/ShapeOptimizationApplication/python_scripts/timer_factory.py b/applications/ShapeOptimizationApplication/python_scripts/timer_factory.py index 32b611c41eaa..025a49a89a2e 100644 --- a/applications/ShapeOptimizationApplication/python_scripts/timer_factory.py +++ b/applications/ShapeOptimizationApplication/python_scripts/timer_factory.py @@ -4,7 +4,7 @@ # License: BSD License # license: ShapeOptimizationApplication/license.txt # -# Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +# Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner # Geiser Armin, https://github.com/armingeiser # # ============================================================================== diff --git a/applications/ShapeOptimizationApplication/shape_optimization_application.cpp b/applications/ShapeOptimizationApplication/shape_optimization_application.cpp index cc3052b8f9ce..356f92e57d5b 100644 --- a/applications/ShapeOptimizationApplication/shape_optimization_application.cpp +++ b/applications/ShapeOptimizationApplication/shape_optimization_application.cpp @@ -4,7 +4,7 @@ // License: BSD License // license: ShapeOptimizationApplication/license.txt // -// Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +// Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner // Geiser Armin, https://github.com/armingeiser // // ============================================================================== diff --git a/applications/ShapeOptimizationApplication/shape_optimization_application.h b/applications/ShapeOptimizationApplication/shape_optimization_application.h index 74e50b367207..ffd3bb4c76de 100644 --- a/applications/ShapeOptimizationApplication/shape_optimization_application.h +++ b/applications/ShapeOptimizationApplication/shape_optimization_application.h @@ -4,7 +4,7 @@ // License: BSD License // license: ShapeOptimizationApplication/license.txt // -// Main authors: Baumgärtner Daniel, https://github.com/dbaumgaertner +// Main authors: Baumgaertner Daniel, https://github.com/dbaumgaertner // Geiser Armin, https://github.com/armingeiser // // ============================================================================== diff --git a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/3D_Hook.mdpa b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/3D_Hook.mdpa index bee143f8c4de..f3d4938de5b2 100644 --- a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/3D_Hook.mdpa +++ b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/3D_Hook.mdpa @@ -5,9 +5,6 @@ End ModelPartData Begin Properties 0 End Properties Begin Properties 1 - DENSITY 7.85000E+03 - YOUNG_MODULUS 2.06900E+11 - POISSON_RATIO 2.90000E-01 End Properties Begin Nodes diff --git a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/ProjectParameters.json b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/ProjectParameters.json index 570ef061ed2c..df77263e4cfa 100644 --- a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/ProjectParameters.json +++ b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/ProjectParameters.json @@ -9,13 +9,16 @@ "echo_level" : 0 }, "structure_solver_settings" : { - "solver_type" : "solid_mechanics_static_solver", + "solver_type" : "structural_mechanics_static_solver", "echo_level" : 0, "solution_type" : "Static", "analysis_type" : "Linear", "model_import_settings" : { "input_type" : "mdpa", "input_filename" : "3D_Hook" + }, + "material_import_settings" :{ + "materials_filename": "materials_3D.json" }, "line_search" : false, "convergence_criterion" : "Residual_criterion", @@ -45,9 +48,7 @@ "input_type" : "mdpa", "input_filename" : "3D_Hook" }, - "time_order" : 2, - "mesh_reform_dofs_each_step" : false, - "mesh_compute_reactions" : true + "compute_reactions" : true }, "constraints_process_list" : [{ "python_module" : "impose_vector_value_by_components_process", @@ -66,7 +67,7 @@ }], "loads_process_list" : [{ "python_module" : "assign_scalar_to_conditions_process", - "kratos_module" : "KratosMultiphysics.SolidMechanicsApplication", + "kratos_module" : "KratosMultiphysics", "help" : "This process sets a scalar variable value over a condition", "process_name" : "ApplyScalarOnConditionsProcess", "Parameters" : { diff --git a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/ProjectParameters_with_mass_constraint.json b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/ProjectParameters_with_mass_constraint.json index 4c4af0feee79..b899962fd225 100644 --- a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/ProjectParameters_with_mass_constraint.json +++ b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/ProjectParameters_with_mass_constraint.json @@ -9,13 +9,16 @@ "echo_level" : 0 }, "structure_solver_settings" : { - "solver_type" : "solid_mechanics_static_solver", + "solver_type" : "structural_mechanics_static_solver", "echo_level" : 0, "solution_type" : "Static", "analysis_type" : "Linear", "model_import_settings" : { "input_type" : "mdpa", "input_filename" : "3D_Hook" + }, + "material_import_settings" :{ + "materials_filename": "materials_3D.json" }, "line_search" : false, "convergence_criterion" : "Residual_criterion", @@ -45,9 +48,7 @@ "input_type" : "mdpa", "input_filename" : "3D_Hook" }, - "time_order" : 2, - "mesh_reform_dofs_each_step" : false, - "mesh_compute_reactions" : true + "compute_reactions" : true }, "constraints_process_list" : [{ "python_module" : "impose_vector_value_by_components_process", @@ -66,7 +67,7 @@ }], "loads_process_list" : [{ "python_module" : "assign_scalar_to_conditions_process", - "kratos_module" : "KratosMultiphysics.SolidMechanicsApplication", + "kratos_module" : "KratosMultiphysics", "help" : "This process sets a scalar variable value over a condition", "process_name" : "ApplyScalarOnConditionsProcess", "Parameters" : { @@ -111,7 +112,7 @@ "identifier" : "strain_energy", "use_kratos" : true, "gradient_mode" : "semi_analytic", - "step_size" : 1e-8 + "step_size" : 1e-5 }], "constraints" : [{ "identifier" : "mass", diff --git a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/materials.py b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/materials.py deleted file mode 100644 index 0585b50c0310..000000000000 --- a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/materials.py +++ /dev/null @@ -1,16 +0,0 @@ - -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# Importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.SolidMechanicsApplication import * -#from beam_sections_python_utility import SetProperties -#from beam_sections_python_utility import SetMaterialProperties - -def AssignMaterial(Properties): - # material for solid material - - prop_id = 1; - prop = Properties[prop_id] - mat = LinearElastic3DLaw() - prop.SetValue(CONSTITUTIVE_LAW, mat.Clone()) - diff --git a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/materials_3D.json b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/materials_3D.json new file mode 100644 index 000000000000..ceae05b6b9dd --- /dev/null +++ b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/materials_3D.json @@ -0,0 +1,18 @@ +{ + "properties": [{ + "model_part_name": "Parts_solid", + "properties_id": 0, + "Material": { + "name": "Material", + "constitutive_law": { + "name": "KratosMultiphysics.StructuralMechanicsApplication.LinearElastic3DLaw" + }, + "Variables": { + "KratosMultiphysics.DENSITY": 7.85000E+03, + "KratosMultiphysics.YOUNG_MODULUS": 2.06900E+11, + "KratosMultiphysics.POISSON_RATIO": 2.90000E-01 + }, + "Tables": {} + } + }] +} diff --git a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/run_optimization.py b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/run_optimization.py index 595ebade815e..5a1b45c0df7e 100644 --- a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/run_optimization.py +++ b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/run_optimization.py @@ -2,7 +2,6 @@ #import kratos core and applications from KratosMultiphysics import * -from KratosMultiphysics.SolidMechanicsApplication import * from KratosMultiphysics.StructuralMechanicsApplication import * from KratosMultiphysics.ExternalSolversApplication import * from KratosMultiphysics.ALEApplication import * @@ -114,6 +113,7 @@ def initializeSolutionLoop( self ): CSM_solver.SetEchoLevel(echo_level) mesh_solver.Initialize() + mesh_solver.SetEchoLevel(echo_level) for responseFunctionId in listOfResponseFunctions: listOfResponseFunctions[responseFunctionId].initialize() @@ -138,7 +138,7 @@ def analyzeDesignAndReportToCommunicator( self, currentDesign, optimizationItera self.updateMeshForAnalysis() print("> Time needed for updating the mesh = ",round(timer.time() - startTime,2),"s") - print("\n> Starting SolidMechanicsApplication to solve structure") + print("\n> Starting StructuralMechanicsApplication to solve structure") startTime = timer.time() self.solveStructure( optimizationIteration ) print("> Time needed for solving the structure = ",round(timer.time() - startTime,2),"s") @@ -194,7 +194,7 @@ def updateMeshForAnalysis( self ): mesh_solver.Solve() # Update reference mesh (Since shape updates are imposed as incremental quantities) - mesh_solver.UpdateReferenceMesh() + mesh_solver.get_mesh_motion_solver().UpdateReferenceMesh() # -------------------------------------------------------------------------- def solveStructure( self, optimizationIteration ): diff --git a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/run_optimization_with_mass_constraint.py b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/run_optimization_with_mass_constraint.py index f6ebe3cf996a..161fc07d80e4 100644 --- a/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/run_optimization_with_mass_constraint.py +++ b/applications/ShapeOptimizationApplication/test_examples/01_Strain_Energy_Minimization_3D_Hook/run_optimization_with_mass_constraint.py @@ -2,7 +2,6 @@ #import kratos core and applications from KratosMultiphysics import * -from KratosMultiphysics.SolidMechanicsApplication import * from KratosMultiphysics.StructuralMechanicsApplication import * from KratosMultiphysics.ExternalSolversApplication import * from KratosMultiphysics.ALEApplication import * @@ -114,6 +113,7 @@ def initializeSolutionLoop( self ): CSM_solver.SetEchoLevel(echo_level) mesh_solver.Initialize() + mesh_solver.SetEchoLevel(echo_level) for responseFunctionId in listOfResponseFunctions: listOfResponseFunctions[responseFunctionId].initialize() @@ -138,7 +138,7 @@ def analyzeDesignAndReportToCommunicator( self, currentDesign, optimizationItera self.updateMeshForAnalysis() print("> Time needed for updating the mesh = ",round(timer.time() - startTime,2),"s") - print("\n> Starting SolidMechanicsApplication to solve structure") + print("\n> Starting StructuralMechanicsApplication to solve structure") startTime = timer.time() self.solveStructure( optimizationIteration ) print("> Time needed for solving the structure = ",round(timer.time() - startTime,2),"s") @@ -220,7 +220,7 @@ def updateMeshForAnalysis( self ): mesh_solver.Solve() # Update reference mesh (Since shape updates are imposed as incremental quantities) - mesh_solver.UpdateReferenceMesh() + mesh_solver.get_mesh_motion_solver().UpdateReferenceMesh() # -------------------------------------------------------------------------- def solveStructure( self, optimizationIteration ): diff --git a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/3D_Shell.mdpa b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/3D_Shell.mdpa index d8146537b415..264d0f311c60 100644 --- a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/3D_Shell.mdpa +++ b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/3D_Shell.mdpa @@ -5,10 +5,6 @@ End ModelPartData Begin Properties 0 End Properties Begin Properties 1 - THICKNESS 1.00000E+00 - DENSITY 7.85000E+03 - YOUNG_MODULUS 2.06900E+11 - POISSON_RATIO 2.90000E-01 End Properties Begin Nodes diff --git a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/3D_Shell_fine.mdpa b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/3D_Shell_fine.mdpa index e9e714253933..be4450c5d4a2 100644 --- a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/3D_Shell_fine.mdpa +++ b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/3D_Shell_fine.mdpa @@ -5,10 +5,6 @@ End ModelPartData Begin Properties 0 End Properties Begin Properties 1 - THICKNESS 1.00000E+00 - DENSITY 7.85000E+03 - YOUNG_MODULUS 2.06900E+11 - POISSON_RATIO 2.90000E-01 End Properties Begin Nodes diff --git a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/ProjectParameters.json b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/ProjectParameters.json index 9c0934cbdfa0..44ac2142498f 100644 --- a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/ProjectParameters.json +++ b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/ProjectParameters.json @@ -9,13 +9,16 @@ "echo_level" : 0 }, "solver_settings" : { - "solver_type" : "solid_mechanics_static_solver", + "solver_type" : "structural_mechanics_static_solver", "echo_level" : 0, "solution_type" : "Static", "analysis_type" : "Linear", "model_import_settings" : { "input_type" : "mdpa", "input_filename" : "3D_Shell" + }, + "material_import_settings" :{ + "materials_filename": "materials_2D.json" }, "line_search" : false, "convergence_criterion" : "Residual_criterion", @@ -111,7 +114,7 @@ "identifier" : "strain_energy", "use_kratos" : true, "gradient_mode" : "semi_analytic", - "step_size" : 1e-8 + "step_size" : 1e-8 }], "constraints" : [], "design_variables" : { diff --git a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/ProjectParameters_fine_mesh.json b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/ProjectParameters_fine_mesh.json index c2a7043ca6d9..3ae024f043b7 100644 --- a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/ProjectParameters_fine_mesh.json +++ b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/ProjectParameters_fine_mesh.json @@ -9,13 +9,16 @@ "echo_level" : 0 }, "solver_settings" : { - "solver_type" : "solid_mechanics_static_solver", + "solver_type" : "structural_mechanics_static_solver", "echo_level" : 0, "solution_type" : "Static", "analysis_type" : "Linear", "model_import_settings" : { "input_type" : "mdpa", "input_filename" : "3D_Shell_fine" + }, + "material_import_settings" :{ + "materials_filename": "materials_2D.json" }, "line_search" : false, "convergence_criterion" : "Residual_criterion", diff --git a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/materials.py b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/materials.py deleted file mode 100644 index 0585b50c0310..000000000000 --- a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/materials.py +++ /dev/null @@ -1,16 +0,0 @@ - -from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 -# Importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.SolidMechanicsApplication import * -#from beam_sections_python_utility import SetProperties -#from beam_sections_python_utility import SetMaterialProperties - -def AssignMaterial(Properties): - # material for solid material - - prop_id = 1; - prop = Properties[prop_id] - mat = LinearElastic3DLaw() - prop.SetValue(CONSTITUTIVE_LAW, mat.Clone()) - diff --git a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/materials_2D.json b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/materials_2D.json new file mode 100644 index 000000000000..b5ee64c61fff --- /dev/null +++ b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/materials_2D.json @@ -0,0 +1,19 @@ +{ + "properties": [{ + "model_part_name": "Parts_solid", + "properties_id": 0, + "Material": { + "name": "Shell_Material", + "constitutive_law": { + "name": "KratosMultiphysics.StructuralMechanicsApplication.LinearElasticPlaneStress2DLaw" + }, + "Variables": { + "KratosMultiphysics.DENSITY": 7.85000E+03, + "KratosMultiphysics.YOUNG_MODULUS": 2.06900E+11, + "KratosMultiphysics.POISSON_RATIO": 2.90000E-01, + "KratosMultiphysics.THICKNESS": 1.00000E+00 + }, + "Tables": {} + } + }] +} diff --git a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/run_optimization.py b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/run_optimization.py index 7df207fe4cea..bc532919afda 100644 --- a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/run_optimization.py +++ b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/run_optimization.py @@ -2,7 +2,6 @@ #import kratos core and applications from KratosMultiphysics import * -from KratosMultiphysics.SolidMechanicsApplication import * from KratosMultiphysics.StructuralMechanicsApplication import * from KratosMultiphysics.ExternalSolversApplication import * from KratosMultiphysics.ShapeOptimizationApplication import * @@ -129,7 +128,7 @@ def analyzeDesignAndReportToCommunicator( self, currentDesign, optimizationItera self.updateMeshForAnalysis( currentDesign ) print("> Time needed for updating the mesh = ",round(timer.time() - startTime,2),"s") - print("\n> Starting SolidMechanicsApplication to solve structure") + print("\n> Starting StructuralMechanicsApplication to solve structure") startTime = timer.time() self.solveStructure( optimizationIteration ) print("> Time needed for solving the structure = ",round(timer.time() - startTime,2),"s") diff --git a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/run_optimization_fine_mesh.py b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/run_optimization_fine_mesh.py index 4c03903b84fc..9f83fad9c1ae 100644 --- a/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/run_optimization_fine_mesh.py +++ b/applications/ShapeOptimizationApplication/test_examples/02_Strain_Energy_Minimization_3D_Shell/run_optimization_fine_mesh.py @@ -2,7 +2,6 @@ #import kratos core and applications from KratosMultiphysics import * -from KratosMultiphysics.SolidMechanicsApplication import * from KratosMultiphysics.StructuralMechanicsApplication import * from KratosMultiphysics.ExternalSolversApplication import * from KratosMultiphysics.ShapeOptimizationApplication import * @@ -129,7 +128,7 @@ def analyzeDesignAndReportToCommunicator( self, currentDesign, optimizationItera self.updateMeshForAnalysis( currentDesign ) print("> Time needed for updating the mesh = ",round(timer.time() - startTime,2),"s") - print("\n> Starting SolidMechanicsApplication to solve structure") + print("\n> Starting StructuralMechanicsApplication to solve structure") startTime = timer.time() self.solveStructure( optimizationIteration ) print("> Time needed for solving the structure = ",round(timer.time() - startTime,2),"s") diff --git a/applications/SolidMechanicsApplication/CMakeLists.txt b/applications/SolidMechanicsApplication/CMakeLists.txt index 02f09f058878..64336c6be16e 100644 --- a/applications/SolidMechanicsApplication/CMakeLists.txt +++ b/applications/SolidMechanicsApplication/CMakeLists.txt @@ -24,6 +24,7 @@ set( KRATOS_SOLID_MECHANICS_APPLICATION_SOURCES ${CMAKE_CURRENT_SOURCE_DIR}/custom_elements/linear_solid_element.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_elements/large_displacement_element.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_elements/small_displacement_element.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_elements/small_displacement_bbar_element.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_elements/axisym_small_displacement_element.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_elements/total_lagrangian_element.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_elements/updated_lagrangian_element.cpp @@ -138,7 +139,7 @@ endif(${CMAKE_SYSTEM_NAME} MATCHES "Darwin") if(${INSTALL_TESTING_FILES} MATCHES ON) get_filename_component (CURRENT_DIR_NAME ${CMAKE_CURRENT_SOURCE_DIR} NAME) - install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/tests DESTINATION applications/${CURRENT_DIR_NAME} FILES_MATCHING PATTERN "*.py" PATTERN ".svn" EXCLUDE) + install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/tests DESTINATION applications/${CURRENT_DIR_NAME} FILES_MATCHING PATTERN "*.py" PATTERN "*.json" PATTERN "*.mdpa" PATTERN ".svn" EXCLUDE) endif(${INSTALL_TESTING_FILES} MATCHES ON) if(${INSTALL_PYTHON_FILES} MATCHES ON) diff --git a/applications/SolidMechanicsApplication/custom_conditions/force_load_condition.cpp b/applications/SolidMechanicsApplication/custom_conditions/force_load_condition.cpp index 38031a5c5f4c..26fe0839fb21 100644 --- a/applications/SolidMechanicsApplication/custom_conditions/force_load_condition.cpp +++ b/applications/SolidMechanicsApplication/custom_conditions/force_load_condition.cpp @@ -462,7 +462,7 @@ void ForceLoadCondition::CalculateConditionSystem(LocalSystemComponents& rLocalS double IntegrationWeight = Variables.Jacobian * integration_points[PointNumber].Weight(); - //std::cout<<" Variables.Jacobian "<CalculateAndAddExternalForces( rRightHandSideVector, rVariables, rVectorForce, rIntegrationWeight ); - //KRATOS_WATCH( rRightHandSideVector ) + //std::cout<<" rRightHandSideVectorPart "<::InvertMatrix( RightCauchyGreen, ElasticVariables.CauchyGreenMatrix, ElasticVariables.traceCG); //7.-Green-Lagrange Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { this->CalculateGreenLagrangeStrain(RightCauchyGreen, StrainVector); } @@ -369,7 +369,7 @@ void HyperElastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& rValues) } //6.-Almansi Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { // e= 0.5*(1-invbT*invb) this->CalculateAlmansiStrain(ElasticVariables.CauchyGreenMatrix,StrainVector); diff --git a/applications/SolidMechanicsApplication/custom_constitutive/hyperelastic_U_P_3D_law.cpp b/applications/SolidMechanicsApplication/custom_constitutive/hyperelastic_U_P_3D_law.cpp index 150e692ae441..abeb316072fa 100644 --- a/applications/SolidMechanicsApplication/custom_constitutive/hyperelastic_U_P_3D_law.cpp +++ b/applications/SolidMechanicsApplication/custom_constitutive/hyperelastic_U_P_3D_law.cpp @@ -137,7 +137,7 @@ void HyperElasticUP3DLaw::CalculateMaterialResponsePK2 (Parameters& rValues) //8.-Green-Lagrange Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { this->CalculateGreenLagrangeStrain(RightCauchyGreen, StrainVector); } @@ -286,7 +286,7 @@ void HyperElasticUP3DLaw::CalculateMaterialResponseKirchhoff (Parameters& rValue //8.-Almansi Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { // e= 0.5*(1-invbT*invb) this->CalculateAlmansiStrain(ElasticVariables.CauchyGreenMatrix,StrainVector); diff --git a/applications/SolidMechanicsApplication/custom_constitutive/hyperelastic_plastic_3D_law.cpp b/applications/SolidMechanicsApplication/custom_constitutive/hyperelastic_plastic_3D_law.cpp index 9e355fce6bc1..f493e65076c3 100644 --- a/applications/SolidMechanicsApplication/custom_constitutive/hyperelastic_plastic_3D_law.cpp +++ b/applications/SolidMechanicsApplication/custom_constitutive/hyperelastic_plastic_3D_law.cpp @@ -243,7 +243,7 @@ void HyperElasticPlastic3DLaw::CalculateMaterialResponsePK2 (Parameters& rValue Matrix& ConstitutiveMatrix = rValues.GetConstitutiveMatrix(); //2.-Green-Lagrange Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { TransformStrains (StrainVector, DeformationGradientF, StrainMeasure_Almansi, StrainMeasure_GreenLagrange); } @@ -367,7 +367,7 @@ void HyperElasticPlastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& r ReturnMappingVariables.LameMu_bar = ElasticVariables.LameMu * ( ElasticVariables.traceCG / 3.0 ); //4.-Almansi Strain: - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { // e= 0.5*(1-invbT*invb) this->CalculateAlmansiStrain(ElasticVariables.CauchyGreenMatrix,StrainVector); diff --git a/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_3D_law.cpp b/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_3D_law.cpp index 831aaaa98f1c..80137b7ee8c2 100644 --- a/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_3D_law.cpp +++ b/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_3D_law.cpp @@ -90,7 +90,7 @@ double& LinearElastic3DLaw::GetValue( const Variable& rThisVariable, dou // Matrix& ConstitutiveMatrix = rValues.GetConstitutiveMatrix(); // //2.-Green-Lagrange Strain: -// if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) +// if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) // { // TransformStrains (StrainVector, DeformationGradientF, StrainMeasure_Almansi, StrainMeasure_GreenLagrange); // } @@ -142,7 +142,7 @@ void LinearElastic3DLaw::CalculateMaterialResponsePK2 (Parameters& rValues) // ReferenceTemperature = MaterialProperties[REFERENCE_TEMPERATURE]; - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) //large strains + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) //large strains { //1.-Compute total deformation gradient @@ -239,7 +239,7 @@ void LinearElastic3DLaw::CalculateMaterialResponsePK2 (Parameters& rValues) // Matrix& ConstitutiveMatrix = rValues.GetConstitutiveMatrix(); // //2.-Almansi Strain: -// if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) +// if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) // { // TransformStrains (StrainVector, DeformationGradientF, StrainMeasure_GreenLagrange, StrainMeasure_Almansi); // } @@ -290,7 +290,7 @@ void LinearElastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& rValues // ReferenceTemperature = MaterialProperties[REFERENCE_TEMPERATURE]; - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) //large strains + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) //large strains { //1.-Compute total deformation gradient const Matrix& DeformationGradientF = rValues.GetDeformationGradientF(); @@ -313,7 +313,7 @@ void LinearElastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& rValues const double& DeterminantF = rValues.GetDeterminantF(); //2.-Almansi Strain: - // if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + // if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) // { // TransformStrains (StrainVector, DeformationGradientF, StrainMeasure_GreenLagrange, StrainMeasure_Almansi); // } diff --git a/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_orthotropic_3D_law.cpp b/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_orthotropic_3D_law.cpp index e3e8c72858b9..35ee0fc965c7 100644 --- a/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_orthotropic_3D_law.cpp +++ b/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_orthotropic_3D_law.cpp @@ -82,7 +82,7 @@ void LinearElasticOrthotropic3DLaw::CalculateMaterialResponsePK2 (Parameters& r //-----------------------------// - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { //only needed const Matrix& DeformationGradientF = rValues.GetDeformationGradientF(); @@ -156,7 +156,7 @@ void LinearElasticOrthotropic3DLaw::CalculateMaterialResponseKirchhoff (Paramete //-----------------------------// - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { //2.-Push-Forward Left Cauchy-Green tensor b to the new configuration diff --git a/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_plastic_3D_law.cpp b/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_plastic_3D_law.cpp index a54367f99609..7d3393683851 100644 --- a/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_plastic_3D_law.cpp +++ b/applications/SolidMechanicsApplication/custom_constitutive/linear_elastic_plastic_3D_law.cpp @@ -109,7 +109,7 @@ void LinearElasticPlastic3DLaw::CalculateMaterialResponsePK2 (Parameters& rValu //-----------------------------// - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { //1.-Deformation Gradient @@ -155,6 +155,20 @@ void LinearElasticPlastic3DLaw::CalculateMaterialResponsePK2 (Parameters& rValu Matrix LinearElasticMatrix (VoigtSize,VoigtSize); this->CalculateLinearElasticMatrix(LinearElasticMatrix,YoungModulus,PoissonCoefficient); + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) + { + + //1.-Deformation Gradient + const Matrix& DeformationGradientF = rValues.GetDeformationGradientF(); + + //2.-Right Cauchy Green + Matrix RightCauchyGreen = prod(trans(DeformationGradientF),DeformationGradientF); + + //3.-Green-Lagrange Strain: E= 0.5*(FT*F-1) + this->CalculateGreenLagrangeStrain(RightCauchyGreen,rStrainVector); + + } + //2.-Calculate Total PK2 stress if(Options.Is(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR)) @@ -220,7 +234,7 @@ void LinearElasticPlastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& //-----------------------------// - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { //1.-Compute total deformation gradient const Matrix& DeformationGradientF = rValues.GetDeformationGradientF(); @@ -264,6 +278,19 @@ void LinearElasticPlastic3DLaw::CalculateMaterialResponseKirchhoff (Parameters& Matrix LinearElasticMatrix (VoigtSize,VoigtSize); this->CalculateLinearElasticMatrix(LinearElasticMatrix,YoungModulus,PoissonCoefficient); + + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) + { + //1.-Compute total deformation gradient + const Matrix& DeformationGradientF = rValues.GetDeformationGradientF(); + + //2.-Push-Forward Left Cauchy-Green tensor b to the new configuration + Matrix LeftCauchyGreenMatrix = prod(DeformationGradientF,trans(DeformationGradientF)); + + //3.-Almansi Strain: e= 0.5*(1-invFT*invF) + this->CalculateAlmansiStrain(LeftCauchyGreenMatrix,rStrainVector); + } + //2.-Calculate Total Kirchhoff stress if(Options.Is(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR)) diff --git a/applications/SolidMechanicsApplication/custom_elements/small_displacement_bbar_element.cpp b/applications/SolidMechanicsApplication/custom_elements/small_displacement_bbar_element.cpp new file mode 100644 index 000000000000..0df56c6de253 --- /dev/null +++ b/applications/SolidMechanicsApplication/custom_elements/small_displacement_bbar_element.cpp @@ -0,0 +1,503 @@ +// +// Project Name: KratosSolidMechanicsApplication $ +// Created by: $Author: MCaicedo $ +// Last modified by: $Co-Author: $ +// Date: $Date: July 2017 $ +// Revision: $Revision: 0.0 $ +// +// + +// System includes + +// External includes + +// Project includes +#include "includes/define.h" +#include "custom_elements/small_displacement_bbar_element.hpp" +#include "includes/constitutive_law.h" + +#include "solid_mechanics_application_variables.h" + +namespace Kratos +{ + + +//******************************CONSTRUCTOR******************************************* +//************************************************************************************ + +SmallDisplacementBbarElement::SmallDisplacementBbarElement() + : SmallDisplacementElement() +{ + // DO NOT CALL IT: only needed for Register and Serialization!!! +} + +//******************************CONSTRUCTOR******************************************* +//************************************************************************************ + +SmallDisplacementBbarElement::SmallDisplacementBbarElement(IndexType NewId, + GeometryType::Pointer pGeometry) + : SmallDisplacementElement(NewId, pGeometry) +{ + // DO NOT ADD DOFS HERE!!! +} + +//******************************CONSTRUCTOR******************************************* +//************************************************************************************ + +SmallDisplacementBbarElement::SmallDisplacementBbarElement(IndexType NewId, + GeometryType::Pointer pGeometry, + PropertiesType::Pointer pProperties) + : SmallDisplacementElement(NewId, pGeometry, pProperties) +{ + +} + +//******************************COPY CONSTRUCTOR************************************** +//************************************************************************************ + +SmallDisplacementBbarElement::SmallDisplacementBbarElement(SmallDisplacementBbarElement const& rOther) + : SmallDisplacementElement(rOther) +{ +} + +//*******************************ASSIGMENT OPERATOR*********************************** +//************************************************************************************ + +SmallDisplacementBbarElement& SmallDisplacementBbarElement::operator=(SmallDisplacementBbarElement const& rOther) +{ + SmallDisplacementElement::operator=(rOther); + + return *this; +} + +//*********************************OPERATIONS***************************************** +//************************************************************************************ + +Element::Pointer SmallDisplacementBbarElement::Create(IndexType NewId, + NodesArrayType const& rThisNodes, + PropertiesType::Pointer pProperties) const +{ + return Element::Pointer( new SmallDisplacementBbarElement( NewId, GetGeometry().Create( rThisNodes ), pProperties ) ); +} + +//************************************CLONE******************************************* +//************************************************************************************ + +Element::Pointer SmallDisplacementBbarElement::Clone(IndexType NewId, + NodesArrayType const& rThisNodes) const +{ + SmallDisplacementBbarElement NewElement( NewId, GetGeometry().Create( rThisNodes ), pGetProperties() ); + + //-----------// + + NewElement.mThisIntegrationMethod = mThisIntegrationMethod; + + if (NewElement.mConstitutiveLawVector.size() != mConstitutiveLawVector.size()) + { + NewElement.mConstitutiveLawVector.resize(mConstitutiveLawVector.size()); + + if (NewElement.mConstitutiveLawVector.size() != NewElement.GetGeometry().IntegrationPointsNumber()) + KRATOS_THROW_ERROR(std::logic_error, "constitutive law not has the correct size ", NewElement.mConstitutiveLawVector.size()); + } + + for (unsigned int i = 0; i < mConstitutiveLawVector.size(); i++) + { + NewElement.mConstitutiveLawVector[i] = mConstitutiveLawVector[i]->Clone(); + } + + //-----------// + + NewElement.SetData(this->GetData()); + NewElement.SetFlags(this->GetFlags()); + + return Element::Pointer(new SmallDisplacementBbarElement(NewElement)); +} + +//*******************************DESTRUCTOR******************************************* +//************************************************************************************ + +SmallDisplacementBbarElement::~SmallDisplacementBbarElement() +{ +} + + +//************************************************************************************ +//************************************************************************************ + + +void SmallDisplacementBbarElement::InitializeGeneralVariables(GeneralVariables& rVariables, + const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_TRY + + const unsigned int number_of_nodes = GetGeometry().size(); + const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); + unsigned int voigt_size = 4; // added component zz, necessary for plasticity. + + if (dimension == 3) + { + voigt_size = 6; + } + + rVariables.Initialize(voigt_size, dimension, number_of_nodes); + + // needed parameters for consistency with the general constitutive law: + // small displacements + rVariables.detF = 1.0; + rVariables.F = identity_matrix(dimension); + + // set variables including all integration points values + + // reading shape functions + rVariables.SetShapeFunctions(GetGeometry().ShapeFunctionsValues(mThisIntegrationMethod)); + + // reading shape functions local gradients + rVariables.SetShapeFunctionsGradients(GetGeometry().ShapeFunctionsLocalGradients(mThisIntegrationMethod)); + + // calculating the current jacobian from cartesian coordinates to parent coordinates for all integration points [dx_n+1/d£] + rVariables.j = GetGeometry().Jacobian(rVariables.j, mThisIntegrationMethod); + + // Calculate Delta Position + rVariables.DeltaPosition = CalculateDeltaPosition(rVariables.DeltaPosition); + + // calculating the reference jacobian from cartesian coordinates to parent coordinates for all integration points [dx_n/d£] + rVariables.J = GetGeometry().Jacobian(rVariables.J, mThisIntegrationMethod, rVariables.DeltaPosition); + + // calculate hydrostatic deformation matrix + CalculateHydrostaticDeformationMatrix(rVariables); + + KRATOS_CATCH( "" ) +} + + + +//************* COMPUTING METHODS +//************************************************************************************ +//************************************************************************************ + + +void SmallDisplacementBbarElement::CalculateKinematics(GeneralVariables& rVariables, const double& rPointNumber) +{ + KRATOS_TRY + + // Get the parent coodinates derivative [dN/d£] + const GeometryType::ShapeFunctionsGradientsType& DN_De = rVariables.GetShapeFunctionsGradients(); + // Get the shape functions for the order of the integration method [N] + const Matrix& Ncontainer = rVariables.GetShapeFunctions(); + + // Calculating the inverse of the jacobian and the parameters needed [d£/dx_n] + Matrix InvJ; + MathUtils::InvertMatrix(rVariables.J[rPointNumber], InvJ, rVariables.detJ); + + // Compute cartesian derivatives [dN/dx_n] + noalias(rVariables.DN_DX) = prod(DN_De[rPointNumber], InvJ); + + // Set Shape Functions Values for this integration point + rVariables.N = row(Ncontainer, rPointNumber); + + // Compute the deformation matrix B_bar + this->CalculateDeformationMatrixBbar(rVariables.B, rVariables.H, rVariables.DN_DX); + + // Compute infinitessimal B_bar strain + this->CalculateInfinitesimalStrainBbar(rVariables.B, rVariables.StrainVector); + + KRATOS_CATCH("") +} + + +//************************************************************************************ +//************************************************************************************ + +void SmallDisplacementBbarElement::CalculateInfinitesimalStrainBbar(const Matrix& rB, + Vector& rStrainVector) +{ + KRATOS_TRY + + const unsigned int number_of_nodes = GetGeometry().PointsNumber(); + const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); + + if (dimension == 2) + { + // Infinitesimal Bbar Strain Calculation + if ( rStrainVector.size() != 4 ) rStrainVector.resize( 4, false ); + + for (unsigned int i = 0; i < number_of_nodes; i++) + { + array_1d& Displacement = + GetGeometry()[i].FastGetSolutionStepValue(DISPLACEMENT); + + rStrainVector[0] += Displacement[0] * rB(0, i * 2) + + Displacement[1] * rB(0, i * 2 + 1); // xx + rStrainVector[1] += Displacement[0] * rB(1, i * 2) + + Displacement[1] * rB(1, i * 2 + 1); // yy + rStrainVector[2] += Displacement[0] * rB(2, i * 2) + + Displacement[1] * rB(2, i * 2 + 1); // zz + rStrainVector[3] += Displacement[0] * rB(3, i * 2) + + Displacement[1] * rB(3, i * 2 + 1); // xy + } + } + else if (dimension == 3) + { + + //Infinitesimal Bbar Strain Calculation + if ( rStrainVector.size() != 6 ) rStrainVector.resize( 6, false ); + + + for (unsigned int i = 0; i < number_of_nodes; i++) + { + array_1d& Displacement = + GetGeometry()[i].FastGetSolutionStepValue(DISPLACEMENT); + + rStrainVector[0] += Displacement[0] * rB(0, i * 3) + + Displacement[1] * rB(0, i * 3 + 1) + + Displacement[2] * rB(0, i * 3 + 2); // xx + rStrainVector[1] += Displacement[0] * rB(1, i * 3) + + Displacement[1] * rB(1, i * 3 + 1) + + Displacement[2] * rB(1, i * 3 + 2); // yy + rStrainVector[2] += Displacement[0] * rB(2, i * 3) + + Displacement[1] * rB(2, i * 3 + 1) + + Displacement[2] * rB(2, i * 3 + 2); // zz + rStrainVector[3] += Displacement[0] * rB(3, i * 3) + + Displacement[1] * rB(3, i * 3 + 1) + + Displacement[2] * rB(3, i * 3 + 2); // xy + rStrainVector[4] += Displacement[0] * rB(4, i * 3) + + Displacement[1] * rB(4, i * 3 + 1) + + Displacement[2] * rB(4, i * 3 + 2); // yz + rStrainVector[5] += Displacement[0] * rB(5, i * 3) + + Displacement[1] * rB(5, i * 3 + 1) + + Displacement[2] * rB(5, i * 3 + 2); // xz + } + } + else + { + KRATOS_THROW_ERROR(std::invalid_argument, "something is wrong with the dimension", "") + } + + KRATOS_CATCH("") +} + +//************************************************************************************ +//************************************************************************************ + +void SmallDisplacementBbarElement::CalculateDeformationMatrix(Matrix& rB, const Matrix& rDN_DX) +{ + KRATOS_TRY + const unsigned int number_of_nodes = GetGeometry().PointsNumber(); + const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); + unsigned int voigt_size = 4; // added component zz, necessary for plasticity. + + if (dimension == 3) + { + voigt_size = 6; + } + + if (rB.size1() != voigt_size || rB.size2() != dimension * number_of_nodes) + rB.resize(voigt_size, dimension * number_of_nodes, false); + + if (dimension == 2) + { + for (unsigned int i = 0; i < number_of_nodes; i++) + { + unsigned int index = 2 * i; + + rB(0,index + 0) = rDN_DX(i,0); + rB(0,index + 1) = 0.0; + + rB(1,index + 0) = 0.0; + rB(1,index + 1) = rDN_DX(i,1); + + rB(2,index + 0) = 0.0; + rB(2,index + 1) = 0.0; + + rB(3,index + 0) = rDN_DX(i,1); + rB(3,index + 1) = rDN_DX(i,0); + } + } + else if (dimension == 3) + { + for (unsigned int i = 0; i < number_of_nodes; i++) + { + unsigned int index = 3 * i; + + rB(0,index + 0) = rDN_DX(i,0); + rB(1,index + 1) = rDN_DX(i,1); + rB(2,index + 2) = rDN_DX(i,2); + + rB(3,index + 0) = rDN_DX(i,1); + rB(3,index + 1) = rDN_DX(i,0); + + rB(4,index + 1) = rDN_DX(i,2); + rB(4,index + 2) = rDN_DX(i,1); + + rB(5,index + 0) = rDN_DX(i,2); + rB(5,index + 2) = rDN_DX(i,0); + } + } + else + { + KRATOS_THROW_ERROR(std::invalid_argument, "something is wrong with the dimension", "") + } + + KRATOS_CATCH("") +} + +//************************************************************************************ +//************************************************************************************ + +void SmallDisplacementBbarElement::CalculateDeformationMatrixBbar(Matrix& rB, + const Matrix& rH, + const Matrix& rDN_DX) // JLM debe entrar rBh +{ + KRATOS_TRY + const unsigned int number_of_nodes = GetGeometry().PointsNumber(); + const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); + unsigned int voigt_size = 4; // added component zz, necessary for plasticity. + + if (dimension == 3) + { + voigt_size = 6; + } + + // Inicializar Auxiliar B matrix + Matrix B; + this->CalculateDeformationMatrix(B, rDN_DX); + + if ( rB.size1() != voigt_size || rB.size2() != dimension*number_of_nodes ) + rB.resize(voigt_size, dimension*number_of_nodes, false ); + + double athird = 1.0/3.0; + + if (dimension == 2) + { + rB(0,0) = 2.0 * athird * B(0,0); + rB(0,1) = -athird * B(1,1); + + rB(0,2) = 2.0 * athird * B(0,2); + rB(0,3) = -athird * B(1,3); + rB(0,4) = 2.0 * athird * B(0,4); + rB(0,5) = -athird * B(1,5); + rB(0,6) = 2.0 * athird * B(0,6); + rB(0,7) = -athird * B(1,7); + + rB(1,0) = -athird * B(0,0); + rB(1,1) = 2.0 * athird * B(1,1); + + rB(1,2) = -athird * B(0,2); + rB(1,3) = 2.0 * athird * B(1,3); + rB(1,4) = -athird * B(0,4); + rB(1,5) = 2.0 * athird * B(1,5); + rB(1,6) = -athird * B(0,6); + rB(1,7) = 2.0 * athird * B(1,7); + + rB(2,0) = -athird * B(0,0); + rB(2,1) = -athird * B(1,1); + + rB(2,2) = -athird * B(0,2); + rB(2,3) = -athird * B(1,3); + rB(2,4) = -athird * B(0,4); + rB(2,5) = -athird * B(1,5); + rB(2,6) = -athird * B(0,6); + rB(2,7) = -athird * B(1,7); + + for (unsigned int i = 0; i < number_of_nodes * dimension; i++) + { + // unsigned int index = 2 * i; + rB(0,i) += athird * rH(i,0); + rB(1,i) += athird * rH(i,0); + rB(2,i) += athird * rH(i,0); + rB(3,i) = B(3,i); + } + } + else if (dimension == 3) + { + for (unsigned int i = 0; i < number_of_nodes; i++) + { + unsigned int index = 3 * i; + + rB(0,index + 0) = 2.0 * athird * B(0,index + 0); + rB(1,index + 0) = -athird * B(0,index + 0); + rB(2,index + 0) = -athird * B(0,index + 0); + rB(0,index + 1) = -athird * B(1,index + 1); + rB(1,index + 1) = 2.0 * athird * B(1,index + 1); + rB(2,index + 1) = -athird * B(1,index + 1); + rB(0,index + 2) = -athird * B(2,index + 2); + rB(1,index + 2) = -athird * B(2,index + 2); + rB(2,index + 2) = 2.0 * athird * B(2,index + 2); + } + for (unsigned int i = 0; i < number_of_nodes * dimension; i++) + { + rB(0,i) += athird * rH(i,0); + rB(1,i) += athird * rH(i,0); + rB(2,i) += athird * rH(i,0); + rB(3,i) = B(3,i); + rB(4,i) = B(4,i); + rB(5,i) = B(5,i); + } + } + else + { + KRATOS_THROW_ERROR(std::invalid_argument, + "something is wrong with the dimension", "") + } + + + KRATOS_CATCH("") +} + +void SmallDisplacementBbarElement::CalculateHydrostaticDeformationMatrix(GeneralVariables& rVariables) +{ + KRATOS_TRY + + const unsigned int number_of_nodes = GetGeometry().PointsNumber(); + const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); + + // if (rB.size1() != voigt_size || rB.size2() != dimension*number_of_nodes) + // rB.resize(voigt_size, dimension*number_of_nodes, false); + + rVariables.H.resize(dimension * number_of_nodes, 1, false); + rVariables.H.clear(); + + // reading integration points + const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints(mThisIntegrationMethod); + + double DomainSize = 0.0; + for (unsigned int PointNumber = 0; PointNumber < integration_points.size(); PointNumber++) + { + const GeometryType::ShapeFunctionsGradientsType& DN_De = rVariables.GetShapeFunctionsGradients(); + + Matrix InvJ; + MathUtils::InvertMatrix(rVariables.J[PointNumber], InvJ, rVariables.detJ); + noalias(rVariables.DN_DX) = prod(DN_De[PointNumber], InvJ); + + this->CalculateDeformationMatrix(rVariables.B, rVariables.DN_DX); + + double IntegrationWeight = integration_points[PointNumber].Weight() * rVariables.detJ; + DomainSize += IntegrationWeight; + + unsigned int index = 0; + for (unsigned int i = 0; i < number_of_nodes; i++) + { + for (unsigned int j= 0; j < dimension; j++) + { + index = i * dimension + j; + rVariables.H(index,0) += rVariables.B(j, index) * IntegrationWeight; + } + } + } + + rVariables.H /= DomainSize; + + KRATOS_CATCH("") +} + +void SmallDisplacementBbarElement::save(Serializer& rSerializer) const +{ + KRATOS_SERIALIZE_SAVE_BASE_CLASS(rSerializer, SmallDisplacementElement) +} + +void SmallDisplacementBbarElement::load(Serializer& rSerializer) +{ + KRATOS_SERIALIZE_LOAD_BASE_CLASS(rSerializer, SmallDisplacementElement) +} + +} // Namespace Kratos diff --git a/applications/SolidMechanicsApplication/custom_elements/small_displacement_bbar_element.hpp b/applications/SolidMechanicsApplication/custom_elements/small_displacement_bbar_element.hpp new file mode 100644 index 000000000000..9756ae270c10 --- /dev/null +++ b/applications/SolidMechanicsApplication/custom_elements/small_displacement_bbar_element.hpp @@ -0,0 +1,227 @@ +// +// Project Name: KratosSolidMechanicsApplication $ +// Created by: $Author: MCaicedo $ +// Last modified by: $Co-Author: $ +// Date: $Date: July 2017 $ +// Revision: $Revision: 0.0 $ +// +// + +#if !defined(KRATOS_SMALL_DISPLACEMENT_BBAR_ELEMENT_H_INCLUDED) +#define KRATOS_SMALL_DISPLACEMENT_BBAR_ELEMENT_H_INCLUDED + +// System includes + +// External includes + +// Project includes +#include "custom_elements/small_displacement_element.hpp" + +namespace Kratos +{ +///@name Kratos Globals +///@{ +///@} +///@name Type Definitions +///@{ +///@} +///@name Enum's +///@{ +///@} +///@name Functions +///@{ +///@} +///@name Kratos Classes +///@{ + +/// Small Displacement Bbar Element for 3D and 2D geometries. + +/** + * Implements a Small Displacement Lagrangian definition for structural analysis. + * This works for arbitrary geometries in 3D and 2D + */ + +class KRATOS_API(SOLID_MECHANICS_APPLICATION) SmallDisplacementBbarElement + : public SmallDisplacementElement +{ +public: + + ///@name Type Definitions + ///@{ + /// Reference type definition for constitutive laws + typedef ConstitutiveLaw ConstitutiveLawType; + /// Pointer type for constitutive laws + typedef ConstitutiveLawType::Pointer ConstitutiveLawPointerType; + /// StressMeasure from constitutive laws + typedef ConstitutiveLawType::StressMeasure StressMeasureType; + /// Type definition for integration methods + typedef GeometryData::IntegrationMethod IntegrationMethod; + /// Counted pointer of SmallDisplacementBbarElement + KRATOS_CLASS_POINTER_DEFINITION(SmallDisplacementBbarElement); + ///@} + + ///@name Life Cycle + ///@{ + + /// Empty constructor needed for serialization + SmallDisplacementBbarElement(); + + /// Default constructors + SmallDisplacementBbarElement(IndexType NewId, GeometryType::Pointer pGeometry); + + SmallDisplacementBbarElement(IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties); + + /// Copy constructor + SmallDisplacementBbarElement(SmallDisplacementBbarElement const& rOther); + + /// Destructor. + virtual ~SmallDisplacementBbarElement(); + + ///@} + ///@name Operators + ///@{ + + /// Assignment operator. + SmallDisplacementBbarElement& operator=(SmallDisplacementBbarElement const& rOther); + + ///@} + ///@name Operations + ///@{ + + /** + * creates a new total lagrangian updated element pointer + * @param NewId: the ID of the new element + * @param ThisNodes: the nodes of the new element + * @param pProperties: the properties assigned to the new element + * @return a Pointer to the new element + */ + Element::Pointer Create(IndexType NewId, + NodesArrayType const& ThisNodes, + PropertiesType::Pointer pProperties) const; + + /** + * clones the selected element variables, creating a new one + * @param NewId: the ID of the new element + * @param ThisNodes: the nodes of the new element + * @param pProperties: the properties assigned to the new element + * @return a Pointer to the new element + */ + Element::Pointer Clone(IndexType NewId, NodesArrayType const& ThisNodes) const; + + ///@} + ///@name Access + ///@{ + ///@} + ///@name Inquiry + ///@{ + ///@} + ///@name Input and output + ///@{ + ///@} + ///@name Friends + ///@{ + ///@} + +protected: + ///@name Protected static Member Variables + ///@{ + ///@} + ///@name Protected member Variables + ///@{ + ///@} + ///@name Protected Operators + ///@{ + ///@} + ///@name Protected Operations + ///@{ + + + /** + * Calculate Element Kinematics + */ + virtual void CalculateKinematics(GeneralVariables& rVariables, const double& rPointNumber); + + /** + * Initialize Element General Variables + */ + virtual void InitializeGeneralVariables(GeneralVariables& rVariables, + const ProcessInfo& rCurrentProcessInfo); + + /** + * Calculation of the Deformation Matrix BL + */ + void CalculateDeformationMatrix(Matrix& rB, const Matrix& rDN_DX); + + /** + * Calculation of the Hydrostatic Deformation Matrix H + */ + void CalculateHydrostaticDeformationMatrix(GeneralVariables& rVariables); + + /** + * Calculation of the Deformation Matrix B_bar B + */ + void CalculateDeformationMatrixBbar(Matrix& rB, const Matrix& rH, const Matrix& rDN_DX); + + /** + * Calculation of the Infinitesimal B_bar Strain + */ + void CalculateInfinitesimalStrainBbar(const Matrix& rB, Vector& rStrainVector); + + + ///@} + ///@name Protected Access + ///@{ + ///@} + ///@name Protected Inquiry + ///@{ + ///@} + ///@name Protected LifeCycle + ///@{ + ///@} + +private: + ///@name Static Member Variables + ///@{ + ///@} + ///@name Member Variables + ///@{ + ///@} + ///@name Private Operators + ///@{ + ///@} + ///@name Private Operations + ///@{ + ///@} + ///@name Private Access + ///@{ + ///@} + ///@} + ///@name Serialization + ///@{ + friend class Serializer; + + // A private default constructor necessary for serialization + + virtual void save(Serializer& rSerializer) const; + + virtual void load(Serializer& rSerializer); + + ///@name Private Inquiry + ///@{ + ///@} + ///@name Un accessible methods + ///@{ + ///@} + +}; // Class SmallDisplacementBbarElement + +///@} +///@name Type Definitions +///@{ +///@} +///@name Input and output +///@{ +///@} + +} // namespace Kratos. +#endif // KRATOS_SMALL_DISPLACEMENT_BBAR_ELEMENT_H_INCLUDED defined diff --git a/applications/SolidMechanicsApplication/custom_elements/small_displacement_element.cpp b/applications/SolidMechanicsApplication/custom_elements/small_displacement_element.cpp index d70a234db55c..eef0a4d265b6 100644 --- a/applications/SolidMechanicsApplication/custom_elements/small_displacement_element.cpp +++ b/applications/SolidMechanicsApplication/custom_elements/small_displacement_element.cpp @@ -485,10 +485,10 @@ void SmallDisplacementElement::Initialize() { KRATOS_TRY - // NOTE: - // The following check on the constitutiveLawVector size - // has been moved into the method InitializeMaterial() - + // NOTE: + // The following check on the constitutiveLawVector size + // has been moved into the method InitializeMaterial() + //const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints( mThisIntegrationMethod ); ////Constitutive Law initialisation //if ( mConstitutiveLawVector.size() != integration_points.size() ) @@ -499,7 +499,6 @@ void SmallDisplacementElement::Initialize() //Material initialisation InitializeMaterial(); - KRATOS_CATCH( "" ) } @@ -511,7 +510,8 @@ void SmallDisplacementElement::SetGeneralVariables(GeneralVariables& rVariables, ConstitutiveLaw::Parameters& rValues, const int & rPointNumber) { - + KRATOS_TRY + rValues.SetStrainVector(rVariables.StrainVector); rValues.SetStressVector(rVariables.StressVector); rValues.SetConstitutiveMatrix(rVariables.ConstitutiveMatrix); @@ -524,7 +524,8 @@ void SmallDisplacementElement::SetGeneralVariables(GeneralVariables& rVariables, rValues.SetDeterminantF(rVariables.detF); rValues.SetDeformationGradientF(rVariables.F); - + + KRATOS_CATCH( "" ) } //************************************************************************************ @@ -532,7 +533,8 @@ void SmallDisplacementElement::SetGeneralVariables(GeneralVariables& rVariables, void SmallDisplacementElement::InitializeGeneralVariables (GeneralVariables & rVariables, const ProcessInfo& rCurrentProcessInfo) { - + KRATOS_TRY + const unsigned int number_of_nodes = GetGeometry().size(); const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); const unsigned int voigt_size = dimension * (dimension +1) * 0.5; @@ -561,6 +563,7 @@ void SmallDisplacementElement::InitializeGeneralVariables (GeneralVariables & rV //calculating the reference jacobian from cartesian coordinates to parent coordinates for all integration points [dx_n/d£] rVariables.J = GetGeometry().Jacobian( rVariables.J, mThisIntegrationMethod, rVariables.DeltaPosition ); + KRATOS_CATCH( "" ) } @@ -572,6 +575,7 @@ void SmallDisplacementElement::InitializeSystemMatrices(MatrixType& rLeftHandSid Flags& rCalculationFlags) { + KRATOS_TRY const unsigned int number_of_nodes = GetGeometry().size(); const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); @@ -596,6 +600,8 @@ void SmallDisplacementElement::InitializeSystemMatrices(MatrixType& rLeftHandSid noalias(rRightHandSideVector) = ZeroVector( MatSize ); //resetting RHS } + + KRATOS_CATCH( "" ) } @@ -1178,57 +1184,57 @@ void SmallDisplacementElement::InitializeMaterial() { KRATOS_TRY - // NOTE: - // This is the standard (previous) implementation: - // If we are here, it means that no one already set up the constitutive law vector - // through the method SetValue + // NOTE: + // This is the standard (previous) implementation: + // If we are here, it means that no one already set up the constitutive law vector + // through the method SetValue - const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints( mThisIntegrationMethod ); + const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints( mThisIntegrationMethod ); - //Constitutive Law initialization + //Constitutive Law initialization if ( mConstitutiveLawVector.size() != integration_points.size() ) - { + { mConstitutiveLawVector.resize( integration_points.size() ); - } - else - { - // check whether the constitutive law pointers have been already set up - bool already_set_up = true; - for(unsigned int i = 0; i < mConstitutiveLawVector.size(); i++) - { - if(mConstitutiveLawVector[i] == NULL) - already_set_up = false; - } - if(already_set_up) - { - for ( unsigned int i = 0; i < mConstitutiveLawVector.size(); i++ ) - { - mConstitutiveLawVector[i]->InitializeMaterial( GetProperties(), GetGeometry(), - row( GetGeometry().ShapeFunctionsValues( mThisIntegrationMethod ), i ) ); - } - return; // if so, we are done here! - } - } + } + else + { + // check whether the constitutive law pointers have been already set up + bool already_set_up = true; + for(unsigned int i = 0; i < mConstitutiveLawVector.size(); i++) + { + if(mConstitutiveLawVector[i] == NULL) + already_set_up = false; + } + if(already_set_up) + { + for ( unsigned int i = 0; i < mConstitutiveLawVector.size(); i++ ) + { + mConstitutiveLawVector[i]->InitializeMaterial( GetProperties(), GetGeometry(), + row( GetGeometry().ShapeFunctionsValues( mThisIntegrationMethod ), i ) ); + } + return; // if so, we are done here! + } + } - // NOTE: - // This is the standard (previous) implementation: - // If we are here, it means that no one already set up the constitutive law vector - // through the method SetValue + // NOTE: + // This is the standard (previous) implementation: + // If we are here, it means that no one already set up the constitutive law vector + // through the method SetValue if ( GetProperties()[CONSTITUTIVE_LAW] != NULL ) - { + { for ( unsigned int i = 0; i < mConstitutiveLawVector.size(); i++ ) - { + { mConstitutiveLawVector[i] = GetProperties()[CONSTITUTIVE_LAW]->Clone(); mConstitutiveLawVector[i]->InitializeMaterial( GetProperties(), GetGeometry(), - row( GetGeometry().ShapeFunctionsValues( mThisIntegrationMethod ), i ) ); - } - } + row( GetGeometry().ShapeFunctionsValues( mThisIntegrationMethod ), i ) ); + } + } else - { + { KRATOS_THROW_ERROR( std::logic_error, "a constitutive law needs to be specified for the element with ID ", this->Id() ) - } - KRATOS_CATCH( "" ) + } + KRATOS_CATCH( "" ) } @@ -1425,9 +1431,7 @@ void SmallDisplacementElement::AddExplicitContribution(const VectorType& rRHSVec //************************************************************************************ -void SmallDisplacementElement::CalculateKinematics(GeneralVariables& rVariables, - const double& rPointNumber) - +void SmallDisplacementElement::CalculateKinematics(GeneralVariables& rVariables, const double& rPointNumber) { KRATOS_TRY @@ -1511,8 +1515,7 @@ Matrix& SmallDisplacementElement::CalculateDeltaPosition(Matrix & rDeltaPosition //*************************COMPUTE DISPLACEMENT GRADIENT****************************** //************************************************************************************ -void SmallDisplacementElement::CalculateDisplacementGradient(Matrix& rH, - const Matrix& rDN_DX) +void SmallDisplacementElement::CalculateDisplacementGradient(Matrix& rH, const Matrix& rDN_DX) { KRATOS_TRY @@ -1568,8 +1571,7 @@ void SmallDisplacementElement::CalculateDisplacementGradient(Matrix& rH, //************************************************************************************ //************************************************************************************ -void SmallDisplacementElement::CalculateInfinitesimalStrain(const Matrix& rH, - Vector& rStrainVector ) +void SmallDisplacementElement::CalculateInfinitesimalStrain(const Matrix& rH, Vector& rStrainVector ) { KRATOS_TRY @@ -1656,10 +1658,10 @@ void SmallDisplacementElement::CalculateVelocityGradient(const Matrix& rDN_DX, //************************************************************************************ //************************************************************************************ -void SmallDisplacementElement::CalculateDeformationMatrix(Matrix& rB, - const Matrix& rDN_DX) +void SmallDisplacementElement::CalculateDeformationMatrix(Matrix& rB, const Matrix& rDN_DX) { KRATOS_TRY + const unsigned int number_of_nodes = GetGeometry().PointsNumber(); const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); unsigned int voigt_size = dimension * (dimension +1) * 0.5; diff --git a/applications/SolidMechanicsApplication/custom_elements/small_displacement_element.hpp b/applications/SolidMechanicsApplication/custom_elements/small_displacement_element.hpp index c9f6bd132ed1..5b310533fded 100644 --- a/applications/SolidMechanicsApplication/custom_elements/small_displacement_element.hpp +++ b/applications/SolidMechanicsApplication/custom_elements/small_displacement_element.hpp @@ -269,10 +269,7 @@ class KRATOS_API(SOLID_MECHANICS_APPLICATION) SmallDisplacementElement ///@} ///@name Operations ///@{ - /** - * Returns the currently selected integration method - * @return current integration method selected - */ + /** * creates a new total lagrangian updated element pointer * @param NewId: the ID of the new element diff --git a/applications/SolidMechanicsApplication/custom_utilities/shell_cross_section.cpp b/applications/SolidMechanicsApplication/custom_utilities/shell_cross_section.cpp index 22c77a41fe2d..e6701e983703 100644 --- a/applications/SolidMechanicsApplication/custom_utilities/shell_cross_section.cpp +++ b/applications/SolidMechanicsApplication/custom_utilities/shell_cross_section.cpp @@ -799,7 +799,7 @@ namespace Kratos // share common data between section and materials rMaterialValues.SetOptions(rValues.GetOptions()); - rMaterialValues.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + rMaterialValues.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); rMaterialValues.SetShapeFunctionsValues( rValues.GetShapeFunctionsValues() ); rMaterialValues.SetShapeFunctionsDerivatives( rValues.GetShapeFunctionsDerivatives() ); diff --git a/applications/SolidMechanicsApplication/python_scripts/MainSolidFEM.py b/applications/SolidMechanicsApplication/python_scripts/MainSolidFEM.py new file mode 100644 index 000000000000..98d25af9edb5 --- /dev/null +++ b/applications/SolidMechanicsApplication/python_scripts/MainSolidFEM.py @@ -0,0 +1,343 @@ +from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +# Import system python modules +import time as timer +import os + +# Import kratos core and applications +import KratosMultiphysics +import KratosMultiphysics.SolidMechanicsApplication as KratosSolid +import KratosMultiphysics.ExternalSolversApplication as KratosSolvers + +class Solution(object): + + def __init__(self): + + #### TIME MONITORING START #### + + # Time control starts + print(timer.ctime()) + # Measure process time + self.t0p = timer.clock() + # Measure wall time + self.t0w = timer.time() + #### TIME MONITORING END #### + + + #### PARSING THE PARAMETERS #### + + # Import input + parameter_file = open("ProjectParameters.json",'r') + self.ProjectParameters = KratosMultiphysics.Parameters(parameter_file.read()) + + # set echo level + self.echo_level = self.ProjectParameters["problem_data"]["echo_level"].GetInt() + + print(" ") + + # defining the number of threads: + num_threads = self.GetParallelSize() + print("::[KSM Simulation]:: [OMP USING",num_threads,"THREADS ]") + #parallel.PrintOMPInfo() + + + print(" ") + print("::[KSM Simulation]:: [Time Step:", self.ProjectParameters["problem_data"]["time_step"].GetDouble()," echo:", self.echo_level,"]") + + #### Model_part settings start #### + + # Defining the model_part + self.main_model_part = KratosMultiphysics.ModelPart(self.ProjectParameters["problem_data"]["model_part_name"].GetString()) + + #self.main_model_part.ProcessInfo.SetValue(KratosMultiphysics.DIMENSION, self.ProjectParameters["problem_data"]["dimension"].GetInt()) + self.main_model_part.ProcessInfo.SetValue(KratosMultiphysics.DOMAIN_SIZE, self.ProjectParameters["problem_data"]["domain_size"].GetInt()) + self.main_model_part.ProcessInfo.SetValue(KratosMultiphysics.DELTA_TIME, self.ProjectParameters["problem_data"]["time_step"].GetDouble()) + self.main_model_part.ProcessInfo.SetValue(KratosMultiphysics.TIME, self.ProjectParameters["problem_data"]["start_time"].GetDouble()) + + + ###TODO replace this "model" for real one once available in kratos core + self.Model = {self.ProjectParameters["problem_data"]["model_part_name"].GetString() : self.main_model_part} + + #construct the solver (main setting methods are located in the solver_module) + solver_module = __import__(self.ProjectParameters["solver_settings"]["solver_type"].GetString()) + self.solver = solver_module.CreateSolver(self.main_model_part, self.ProjectParameters["solver_settings"]) + + + #### Output settings start #### + + self.problem_path = os.getcwd() + self.problem_name = self.ProjectParameters["problem_data"]["problem_name"].GetString() + + def AddMaterials(self): + + # Assign material to model_parts (if Materials.json exists) + import process_factory + + if os.path.isfile("Materials.json"): + materials_file = open("Materials.json",'r') + MaterialParameters = KratosMultiphysics.Parameters(materials_file.read()) + + if(MaterialParameters.Has("material_models_list")): + + ## Get the list of the model_part's in the object Model + for i in range(self.ProjectParameters["solver_settings"]["problem_domain_sub_model_part_list"].size()): + part_name = self.ProjectParameters["solver_settings"]["problem_domain_sub_model_part_list"][i].GetString() + if( self.main_model_part.HasSubModelPart(part_name) ): + self.Model.update({part_name: self.main_model_part.GetSubModelPart(part_name)}) + + + assign_materials_processes = process_factory.KratosProcessFactory(self.Model).ConstructListOfProcesses( MaterialParameters["material_models_list"] ) + + for process in assign_materials_processes: + process.Execute() + else: + print(" No Materials.json found ") + + + def AddProcesses(self): + + # Build sub_model_parts or submeshes (rearrange parts for the application of custom processes) + ## Get the list of the submodel part in the object Model + for i in range(self.ProjectParameters["solver_settings"]["processes_sub_model_part_list"].size()): + part_name = self.ProjectParameters["solver_settings"]["processes_sub_model_part_list"][i].GetString() + if( self.main_model_part.HasSubModelPart(part_name) ): + self.Model.update({part_name: self.main_model_part.GetSubModelPart(part_name)}) + + # Obtain the list of the processes to be applied + import process_handler + + process_parameters = KratosMultiphysics.Parameters("{}") + process_parameters.AddValue("echo_level", self.ProjectParameters["problem_data"]["echo_level"]) + process_parameters.AddValue("constraints_process_list", self.ProjectParameters["constraints_process_list"]) + process_parameters.AddValue("loads_process_list", self.ProjectParameters["loads_process_list"]) + if( self.ProjectParameters.Has("problem_process_list") ): + process_parameters.AddValue("problem_process_list", self.ProjectParameters["problem_process_list"]) + if( self.ProjectParameters.Has("output_process_list") ): + process_parameters.AddValue("output_process_list", self.ProjectParameters["output_process_list"]) + + return (process_handler.ProcessHandler(self.Model, process_parameters)) + + + def Run(self): + + self.Initialize() + + self.RunMainTemporalLoop() + + self.Finalize() + + + def Initialize(self): + + + #### INITIALIZE #### + + # Add variables (always before importing the model part) + self.solver.AddVariables() + + # Read model_part (note: the buffer_size is set here) (restart is read here) + self.solver.ImportModelPart() + + # Add dofs (always after importing the model part) + if((self.main_model_part.ProcessInfo).Has(KratosMultiphysics.IS_RESTARTED)): + if(self.main_model_part.ProcessInfo[KratosMultiphysics.IS_RESTARTED] == False): + self.solver.AddDofs() + else: + self.solver.AddDofs() + + + # Add materials (assign material to model_parts if Materials.json exists) + self.AddMaterials() + + + # Add processes + self.model_processes = self.AddProcesses() + self.model_processes.ExecuteInitialize() + + + # Print model_part and properties + if(self.echo_level>1): + print("") + print(self.main_model_part) + for properties in self.main_model_part.Properties: + print(properties) + + + #### START SOLUTION #### + + self.computing_model_part = self.solver.GetComputingModelPart() + + ## Sets strategies, builders, linear solvers, schemes and solving info, and fills the buffer + self.solver.Initialize() + #self.solver.InitializeStrategy() + self.solver.SetEchoLevel(self.echo_level) + + + # Initialize GiD I/O (gid outputs, file_lists) + self.SetGraphicalOutput() + + self.GraphicalOutputExecuteInitialize() + + + print(" ") + print("::[KSM Simulation]:: Analysis -START- ") + + self.model_processes.ExecuteBeforeSolutionLoop() + + self.GraphicalOutputExecuteBeforeSolutionLoop() + + # Set time settings + self.step = self.main_model_part.ProcessInfo[KratosMultiphysics.STEP] + self.time = self.main_model_part.ProcessInfo[KratosMultiphysics.TIME] + + self.end_time = self.ProjectParameters["problem_data"]["end_time"].GetDouble() + self.delta_time = self.ProjectParameters["problem_data"]["time_step"].GetDouble() + + + def RunMainTemporalLoop(self): + + # Solving the problem (time integration) + while(self.time < self.end_time): + + self.InitializeSolutionStep() + self.SolveSolutionStep() + self.FinalizeSolutionStep() + + + def InitializeSolutionStep(self): + + # current time parameters + # self.main_model_part.ProcessInfo.GetPreviousSolutionStepInfo()[KratosMultiphysics.DELTA_TIME] = self.delta_time + self.delta_time = self.main_model_part.ProcessInfo[KratosMultiphysics.DELTA_TIME] + + self.time = self.time + self.delta_time + self.step = self.step + 1 + + self.main_model_part.ProcessInfo[KratosMultiphysics.STEP] = self.step + self.main_model_part.CloneTimeStep(self.time) + + + print(" [STEP:",self.step," TIME:",self.time,"]") + + # processes to be executed at the begining of the solution step + self.model_processes.ExecuteInitializeSolutionStep() + + self.GraphicalOutputExecuteInitializeSolutionStep() + + self.solver.InitializeSolutionStep() + + + def SolveSolutionStep(self): + + self.clock_time = self.StartTimeMeasuring(); + + #self.solver.Predict() + + #self.solver.SolveSolutionStep() + + #self.solver.FinalizeSolutionStep() + + self.solver.Solve() + + self.StopTimeMeasuring(self.clock_time,"Solving", False); + + + def FinalizeSolutionStep(self): + + + self.GraphicalOutputExecuteFinalizeSolutionStep() + + # processes to be executed at the end of the solution step + self.model_processes.ExecuteFinalizeSolutionStep() + + # processes to be executed before witting the output + self.model_processes.ExecuteBeforeOutputStep() + + # write output results GiD: (frequency writing is controlled internally) + self.GraphicalOutputPrintOutput() + + # processes to be executed after witting the output + self.model_processes.ExecuteAfterOutputStep() + + + def Finalize(self): + + # Ending the problem (time integration finished) + self.GraphicalOutputExecuteFinalize() + + self.model_processes.ExecuteFinalize() + + print("::[KSM Simulation]:: Analysis -END- ") + print(" ") + + # Check solving information for any problem + #~ self.solver.InfoCheck() # InfoCheck not implemented yet. + + #### END SOLUTION #### + + # Measure process time + tfp = timer.clock() + # Measure wall time + tfw = timer.time() + + print("::[KSM Simulation]:: [Elapsed Time = %.2f" % (tfw - self.t0w),"seconds] (%.2f" % (tfp - self.t0p),"seconds of cpu/s time)") + + print(timer.ctime()) + + + + def SetGraphicalOutput(self): + from gid_output_process import GiDOutputProcess + self.output_settings = self.ProjectParameters["output_configuration"] + self.graphical_output = GiDOutputProcess(self.computing_model_part, + self.problem_name, + self.output_settings) + + def GraphicalOutputExecuteInitialize(self): + self.graphical_output.ExecuteInitialize() + + def GraphicalOutputExecuteBeforeSolutionLoop(self): + # writing a initial state results file or single file (if no restart) + if((self.main_model_part.ProcessInfo).Has(KratosMultiphysics.IS_RESTARTED)): + if(self.main_model_part.ProcessInfo[KratosMultiphysics.IS_RESTARTED] == False): + self.graphical_output.ExecuteBeforeSolutionLoop() + + def GraphicalOutputExecuteInitializeSolutionStep(self): + self.graphical_output.ExecuteInitializeSolutionStep() + + def GraphicalOutputExecuteFinalizeSolutionStep(self): + self.graphical_output.ExecuteFinalizeSolutionStep() + + def GraphicalOutputPrintOutput(self): + if(self.graphical_output.IsOutputStep()): + self.graphical_output.PrintOutput() + + def GraphicalOutputExecuteFinalize(self): + self.graphical_output.ExecuteFinalize() + + + + def SetParallelSize(self, num_threads): + parallel = KratosMultiphysics.OpenMPUtils() + parallel.SetNumThreads(int(num_threads)) + + def GetParallelSize(self): + parallel = KratosMultiphysics.OpenMPUtils() + return parallel.GetNumThreads() + + def StartTimeMeasuring(self): + # Measure process time + time_ip = timer.clock() + return time_ip + + def StopTimeMeasuring(self, time_ip, process, report): + # Measure process time + time_fp = timer.clock() + if( report ): + used_time = time_fp - time_ip + print("::[KSM Simulation]:: [ %.2f" % round(used_time,2),"s", process," ] ") + + +if __name__ == "__main__": + Solution().Run() + diff --git a/applications/SolidMechanicsApplication/solid_mechanics_application.cpp b/applications/SolidMechanicsApplication/solid_mechanics_application.cpp index 5188075db54c..a4f306bedb22 100644 --- a/applications/SolidMechanicsApplication/solid_mechanics_application.cpp +++ b/applications/SolidMechanicsApplication/solid_mechanics_application.cpp @@ -77,6 +77,9 @@ namespace Kratos mSmallDisplacementElement3D20N( 0, Element::GeometryType::Pointer( new Hexahedra3D20 >( Element::GeometryType::PointsArrayType( 20 ) ) ) ), mSmallDisplacementElement3D27N( 0, Element::GeometryType::Pointer( new Hexahedra3D27 >( Element::GeometryType::PointsArrayType( 27 ) ) ) ), + mSmallDisplacementBbarElement2D3N( 0, Element::GeometryType::Pointer( new Triangle2D3 >( Element::GeometryType::PointsArrayType( 3 ) ) ) ), + mSmallDisplacementBbarElement3D4N( 0, Element::GeometryType::Pointer( new Tetrahedra3D4 >( Element::GeometryType::PointsArrayType( 4 ) ) ) ), + mAxisymSmallDisplacementElement2D3N( 0, Element::GeometryType::Pointer( new Triangle2D3 >( Element::GeometryType::PointsArrayType( 3 ) ) ) ), mAxisymSmallDisplacementElement2D4N( 0, Element::GeometryType::Pointer( new Quadrilateral2D4 >( Element::GeometryType::PointsArrayType( 4 ) ) ) ), mAxisymSmallDisplacementElement2D6N( 0, Element::GeometryType::Pointer( new Triangle2D6 >( Element::GeometryType::PointsArrayType( 6 ) ) ) ), @@ -239,6 +242,9 @@ namespace Kratos KRATOS_REGISTER_ELEMENT( "SmallDisplacementElement3D20N", mSmallDisplacementElement3D20N ) KRATOS_REGISTER_ELEMENT( "SmallDisplacementElement3D27N", mSmallDisplacementElement3D27N ) + KRATOS_REGISTER_ELEMENT( "SmallDisplacementBbarElement2D3N", mSmallDisplacementBbarElement2D3N ) + KRATOS_REGISTER_ELEMENT( "SmallDisplacementBbarElement3D4N", mSmallDisplacementBbarElement3D4N ) + KRATOS_REGISTER_ELEMENT( "AxisymSmallDisplacementElement2D3N", mAxisymSmallDisplacementElement2D3N ) KRATOS_REGISTER_ELEMENT( "AxisymSmallDisplacementElement2D4N", mAxisymSmallDisplacementElement2D4N ) KRATOS_REGISTER_ELEMENT( "AxisymSmallDisplacementElement2D6N", mAxisymSmallDisplacementElement2D6N ) diff --git a/applications/SolidMechanicsApplication/solid_mechanics_application.h b/applications/SolidMechanicsApplication/solid_mechanics_application.h index 8189d1e8cbdf..d26fc9de2552 100644 --- a/applications/SolidMechanicsApplication/solid_mechanics_application.h +++ b/applications/SolidMechanicsApplication/solid_mechanics_application.h @@ -52,6 +52,7 @@ #include "custom_elements/linear_solid_element.hpp" #include "custom_elements/small_displacement_element.hpp" +#include "custom_elements/small_displacement_bbar_element.hpp" #include "custom_elements/axisym_small_displacement_element.hpp" #include "custom_elements/total_lagrangian_element.hpp" @@ -304,6 +305,9 @@ typedef array_1d Vector6; const SmallDisplacementElement mSmallDisplacementElement3D20N; const SmallDisplacementElement mSmallDisplacementElement3D27N; + const SmallDisplacementBbarElement mSmallDisplacementBbarElement2D3N; + const SmallDisplacementBbarElement mSmallDisplacementBbarElement3D4N; + const AxisymSmallDisplacementElement mAxisymSmallDisplacementElement2D3N; const AxisymSmallDisplacementElement mAxisymSmallDisplacementElement2D4N; const AxisymSmallDisplacementElement mAxisymSmallDisplacementElement2D6N; diff --git a/applications/StructuralMechanicsApplication/CMakeLists.txt b/applications/StructuralMechanicsApplication/CMakeLists.txt index 95a52e0deb0b..73adb6eac1d3 100644 --- a/applications/StructuralMechanicsApplication/CMakeLists.txt +++ b/applications/StructuralMechanicsApplication/CMakeLists.txt @@ -96,12 +96,12 @@ endif(${CMAKE_SYSTEM_NAME} MATCHES "Darwin") if(${INSTALL_TESTING_FILES} MATCHES ON) get_filename_component (CURRENT_DIR_NAME ${CMAKE_CURRENT_SOURCE_DIR} NAME) - install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/tests DESTINATION applications/${CURRENT_DIR_NAME} FILES_MATCHING PATTERN "*.py" EXCLUDE) + install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/tests DESTINATION applications/${CURRENT_DIR_NAME} FILES_MATCHING PATTERN "*.py" PATTERN "*.json" PATTERN "*.mdpa" PATTERN ".svn" EXCLUDE) endif(${INSTALL_TESTING_FILES} MATCHES ON) if(${INSTALL_PYTHON_FILES} MATCHES ON) get_filename_component (CURRENT_DIR_NAME ${CMAKE_CURRENT_SOURCE_DIR} NAME) - install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/python_scripts DESTINATION applications/${CURRENT_DIR_NAME} FILES_MATCHING PATTERN "*.py" PATTERN "*.csv") + install(DIRECTORY ${CMAKE_CURRENT_SOURCE_DIR}/python_scripts DESTINATION applications/${CURRENT_DIR_NAME} FILES_MATCHING PATTERN "*.py" PATTERN "*.csv") endif(${INSTALL_PYTHON_FILES} MATCHES ON) # get_property(inc_dirs DIRECTORY PROPERTY INCLUDE_DIRECTORIES) diff --git a/applications/StructuralMechanicsApplication/custom_conditions/line_load_condition_2d.cpp b/applications/StructuralMechanicsApplication/custom_conditions/line_load_condition_2d.cpp index bd671e6710cf..eaa353a4852d 100644 --- a/applications/StructuralMechanicsApplication/custom_conditions/line_load_condition_2d.cpp +++ b/applications/StructuralMechanicsApplication/custom_conditions/line_load_condition_2d.cpp @@ -7,6 +7,7 @@ // license: structural_mechanics_application/license.txt // // Main authors: Riccardo Rossi +// Vicente Mataix // // System includes @@ -84,133 +85,125 @@ namespace Kratos { KRATOS_TRY; - const unsigned int NumberOfNodes = GetGeometry().size(); - const unsigned int Dimension = GetGeometry().WorkingSpaceDimension(); + const unsigned int number_of_nodes = GetGeometry().size(); + const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); // Resizing as needed the LHS - const unsigned int MatSize = NumberOfNodes * Dimension; + const unsigned int mat_size = number_of_nodes * dimension; if ( CalculateStiffnessMatrixFlag == true ) //calculation of the matrix is required { - if ( rLeftHandSideMatrix.size1() != MatSize ) + if ( rLeftHandSideMatrix.size1() != mat_size ) { - rLeftHandSideMatrix.resize( MatSize, MatSize, false ); + rLeftHandSideMatrix.resize( mat_size, mat_size, false ); } - noalias( rLeftHandSideMatrix ) = ZeroMatrix( MatSize, MatSize ); //resetting LHS + noalias( rLeftHandSideMatrix ) = ZeroMatrix( mat_size, mat_size ); //resetting LHS } //resizing as needed the RHS if ( CalculateResidualVectorFlag == true ) //calculation of the matrix is required { - if ( rRightHandSideVector.size( ) != MatSize ) + if ( rRightHandSideVector.size( ) != mat_size ) { - rRightHandSideVector.resize( MatSize, false ); + rRightHandSideVector.resize( mat_size, false ); } - noalias( rRightHandSideVector ) = ZeroVector( MatSize ); //resetting RHS + noalias( rRightHandSideVector ) = ZeroVector( mat_size ); //resetting RHS } - IntegrationMethod IntegrationMethod = IntegrationUtilities::GetIntegrationMethodForExactMassMatrixEvaluation(GetGeometry()); + IntegrationMethod integration_method = IntegrationUtilities::GetIntegrationMethodForExactMassMatrixEvaluation(GetGeometry()); // Reading integration points and local gradients - const GeometryType::IntegrationPointsArrayType& IntegrationPoints = GetGeometry().IntegrationPoints(IntegrationMethod); + const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints(integration_method); - const GeometryType::ShapeFunctionsGradientsType& DN_De = GetGeometry().ShapeFunctionsLocalGradients(IntegrationMethod); + const GeometryType::ShapeFunctionsGradientsType& DN_De = GetGeometry().ShapeFunctionsLocalGradients(integration_method); - const Matrix& Ncontainer = GetGeometry().ShapeFunctionsValues(IntegrationMethod); + const Matrix& Ncontainer = GetGeometry().ShapeFunctionsValues(integration_method); - //calculating actual jacobian - GeometryType::JacobiansType J; - - J = GetGeometry().Jacobian( J , IntegrationMethod); - - ////sizing work matrices - Vector PressureOnNodes = ZeroVector( NumberOfNodes ); + // Sizing work matrices + Vector pressure_on_nodes = ZeroVector( number_of_nodes ); // Pressure applied to the element itself - double PressureOnCondition = 0.0; + double pressure_on_condition = 0.0; if( this->Has( PRESSURE ) ) { - PressureOnCondition += this->GetValue( PRESSURE ); + pressure_on_condition += this->GetValue( PRESSURE ); } if( this->Has( NEGATIVE_FACE_PRESSURE ) ) { - PressureOnCondition += this->GetValue( NEGATIVE_FACE_PRESSURE ); + pressure_on_condition += this->GetValue( NEGATIVE_FACE_PRESSURE ); } if( this->Has( POSITIVE_FACE_PRESSURE ) ) { - PressureOnCondition -= this->GetValue( POSITIVE_FACE_PRESSURE ); + pressure_on_condition -= this->GetValue( POSITIVE_FACE_PRESSURE ); } - for ( unsigned int i = 0; i < PressureOnNodes.size(); i++ ) + for ( unsigned int i = 0; i < pressure_on_nodes.size(); i++ ) { - PressureOnNodes[i] = PressureOnCondition; + pressure_on_nodes[i] = pressure_on_condition; if( GetGeometry()[i].SolutionStepsDataHas( NEGATIVE_FACE_PRESSURE) ) { - PressureOnNodes[i] += GetGeometry()[i].FastGetSolutionStepValue( NEGATIVE_FACE_PRESSURE ); + pressure_on_nodes[i] += GetGeometry()[i].FastGetSolutionStepValue( NEGATIVE_FACE_PRESSURE ); } if( GetGeometry()[i].SolutionStepsDataHas( POSITIVE_FACE_PRESSURE) ) { - PressureOnNodes[i] -= GetGeometry()[i].FastGetSolutionStepValue( POSITIVE_FACE_PRESSURE ); + pressure_on_nodes[i] -= GetGeometry()[i].FastGetSolutionStepValue( POSITIVE_FACE_PRESSURE ); } } // Vector with a loading applied to the elemnt - array_1d LineLoad = ZeroVector(3); + array_1d line_load = ZeroVector(3); if( this->Has( LINE_LOAD ) ) { - noalias(LineLoad) = this->GetValue( LINE_LOAD ); + noalias(line_load) = this->GetValue( LINE_LOAD ); } - array_1d Normal;; //normal direction (not normalized) - for ( unsigned int PointNumber = 0; PointNumber < IntegrationPoints.size(); PointNumber++ ) - { - const double detJ = MathUtils::GeneralizedDet(J[PointNumber]); + for ( unsigned int point_number = 0; point_number < integration_points.size(); point_number++ ) + { + const double det_j = GetGeometry().DeterminantOfJacobian( integration_points[point_number] ); - const double IntegrationWeight = GetIntegrationWeight(IntegrationPoints, PointNumber, detJ); - - Normal[0] = -J[PointNumber]( 1, 0 ); - Normal[1] = J[PointNumber]( 0, 0 ); - Normal /= norm_2(Normal); + const double integration_weight = GetIntegrationWeight(integration_points, point_number, det_j); + + const array_1d normal = GetGeometry().Normal( integration_points[point_number] ); // Calculating the pressure on the gauss point - double GaussPressure = 0.0; - for ( unsigned int ii = 0; ii < NumberOfNodes; ii++ ) + double gauss_pressure = 0.0; + for ( unsigned int ii = 0; ii < number_of_nodes; ii++ ) { - GaussPressure += Ncontainer( PointNumber, ii ) * PressureOnNodes[ii]; + gauss_pressure += Ncontainer( point_number, ii ) * pressure_on_nodes[ii]; } if ( CalculateStiffnessMatrixFlag == true ) { - if ( GaussPressure != 0.0 ) + if ( gauss_pressure != 0.0 ) { - CalculateAndSubKp( rLeftHandSideMatrix, DN_De[PointNumber], row( Ncontainer, PointNumber ), GaussPressure, IntegrationWeight ); + CalculateAndSubKp( rLeftHandSideMatrix, DN_De[point_number], row( Ncontainer, point_number ), gauss_pressure, integration_weight ); } } - //adding contributions to the residual vector + // Adding contributions to the residual vector if ( CalculateResidualVectorFlag == true ) { - if ( GaussPressure != 0.0 ) + if ( gauss_pressure != 0.0 ) { - CalculateAndAddPressureForce( rRightHandSideVector, row( Ncontainer, PointNumber ), Normal, GaussPressure, IntegrationWeight ); + CalculateAndAddPressureForce( rRightHandSideVector, row( Ncontainer, point_number ), normal, gauss_pressure, integration_weight ); } } - array_1d GaussLoad = LineLoad; - for (unsigned int ii = 0; ii < NumberOfNodes; ++ii) + array_1d gauss_load = line_load; + for (unsigned int ii = 0; ii < number_of_nodes; ++ii) { if( GetGeometry()[ii].SolutionStepsDataHas( LINE_LOAD ) ) { - noalias(GaussLoad) += ( Ncontainer( PointNumber, ii ))*GetGeometry()[ii].FastGetSolutionStepValue( LINE_LOAD ); + noalias(gauss_load) += ( Ncontainer( point_number, ii )) * GetGeometry()[ii].FastGetSolutionStepValue( LINE_LOAD ); } } - for (unsigned int ii = 0; ii < NumberOfNodes; ++ii) + for (unsigned int ii = 0; ii < number_of_nodes; ++ii) { - const unsigned int base = ii * Dimension; - for(unsigned int k = 0; k < Dimension; ++k) + const unsigned int base = ii * dimension; + for(unsigned int k = 0; k < dimension; ++k) { - rRightHandSideVector[base + k] += IntegrationWeight * Ncontainer( PointNumber, ii )*GaussLoad[k]; + rRightHandSideVector[base + k] += integration_weight * Ncontainer( point_number, ii ) * gauss_load[k]; } } } @@ -267,21 +260,21 @@ namespace Kratos void LineLoadCondition2D::CalculateAndAddPressureForce( Vector& rRightHandSideVector, const Vector& N, - array_1d& Normal, + const array_1d& Normal, double Pressure, double IntegrationWeight ) { - const unsigned int NumberOfNodes = GetGeometry().size(); - const unsigned int Dimension = 2; + const unsigned int number_of_nodes = GetGeometry().size(); + const unsigned int dimension = 2; - for ( unsigned int i = 0; i < NumberOfNodes; i++ ) + for ( unsigned int i = 0; i < number_of_nodes; i++ ) { - const int index = Dimension * i; + const int index = dimension * i; const double coeff = Pressure * N[i] * IntegrationWeight; - rRightHandSideVector[index] += coeff * Normal[0]; - rRightHandSideVector[index+1] += coeff * Normal[1]; + rRightHandSideVector[index ] -= coeff * Normal[0]; + rRightHandSideVector[index + 1] -= coeff * Normal[1]; } } diff --git a/applications/StructuralMechanicsApplication/custom_conditions/line_load_condition_2d.h b/applications/StructuralMechanicsApplication/custom_conditions/line_load_condition_2d.h index 874a2db3be6a..288ea060d003 100644 --- a/applications/StructuralMechanicsApplication/custom_conditions/line_load_condition_2d.h +++ b/applications/StructuralMechanicsApplication/custom_conditions/line_load_condition_2d.h @@ -170,7 +170,7 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) LineLoadCondition2D void CalculateAndAddPressureForce( VectorType& rRightHandSideVector, const Vector& N, - array_1d& Normal, + const array_1d& Normal, const double Pressure, const double IntegrationWeight ); diff --git a/applications/StructuralMechanicsApplication/custom_conditions/surface_load_condition_3d.cpp b/applications/StructuralMechanicsApplication/custom_conditions/surface_load_condition_3d.cpp index 1e3b7ee057a6..b1ce68ffe8fe 100644 --- a/applications/StructuralMechanicsApplication/custom_conditions/surface_load_condition_3d.cpp +++ b/applications/StructuralMechanicsApplication/custom_conditions/surface_load_condition_3d.cpp @@ -7,6 +7,7 @@ // license: structural_mechanics_application/license.txt // // Main authors: Riccardo Rossi +// Vicente Mataix // // System includes @@ -89,12 +90,12 @@ namespace Kratos void SurfaceLoadCondition3D::CalculateAndSubKp( Matrix& K, - array_1d & ge, - array_1d & gn, + const array_1d& ge, + const array_1d& gn, const Matrix& DN_De, const Vector& N, - double pressure, - double weight) + const double Pressure, + const double Weight) { KRATOS_TRY @@ -102,22 +103,22 @@ namespace Kratos bounded_matrix Cross_ge; bounded_matrix Cross_gn; double coeff; - const unsigned int NumberOfNodes = GetGeometry().size(); + const unsigned int number_of_nodes = GetGeometry().size(); MakeCrossMatrix(Cross_ge, ge); MakeCrossMatrix(Cross_gn, gn); - for (unsigned int i = 0; i < NumberOfNodes; i++) + for (unsigned int i = 0; i < number_of_nodes; i++) { const unsigned int RowIndex = i * 3; - for (unsigned int j = 0; j < NumberOfNodes; j++) + for (unsigned int j = 0; j < number_of_nodes; j++) { const unsigned int ColIndex = j * 3; - coeff = pressure * N[i] * DN_De(j, 1) * weight; + coeff = Pressure * N[i] * DN_De(j, 1) * Weight; noalias(Kij) = coeff * Cross_ge; - coeff = pressure * N[i] * DN_De(j, 0) * weight; + coeff = Pressure * N[i] * DN_De(j, 0) * Weight; noalias(Kij) -= coeff * Cross_gn; @@ -134,7 +135,7 @@ namespace Kratos void SurfaceLoadCondition3D::MakeCrossMatrix( bounded_matrix & M, - array_1d & U) + const array_1d & U) { M(0, 0) = 0.0; M(0, 1) = -U[2]; @@ -151,25 +152,25 @@ namespace Kratos //*********************************************************************************** void SurfaceLoadCondition3D::CalculateAndAddPressureForce( - VectorType& residualvector, + VectorType& rResidualVector, const Vector& N, - const array_1d& v3, - double pressure, - double weight, + const array_1d& Normal, + const double Pressure, + const double Weight, const ProcessInfo& rCurrentProcessInfo ) { KRATOS_TRY; - const unsigned int NumberOfNodes = GetGeometry().size(); + const unsigned int number_of_nodes = GetGeometry().size(); - for (unsigned int i = 0; i < NumberOfNodes; i++) + for (unsigned int i = 0; i < number_of_nodes; i++) { const int index = 3 * i; - const double coeff = pressure * N[i] * weight; - residualvector[index] += coeff * v3[0]; - residualvector[index + 1] += coeff * v3[1]; - residualvector[index + 2] += coeff * v3[2]; + const double coeff = Pressure * N[i] * Weight; + rResidualVector[index ] -= coeff * Normal[0]; + rResidualVector[index + 1] -= coeff * Normal[1]; + rResidualVector[index + 2] -= coeff * Normal[2]; } KRATOS_CATCH("") @@ -188,34 +189,34 @@ namespace Kratos { KRATOS_TRY; - const unsigned int NumberOfNodes = GetGeometry().size(); - const unsigned int MatSize = NumberOfNodes * 3; + const unsigned int number_of_nodes = GetGeometry().size(); + const unsigned int mat_size = number_of_nodes * 3; //Resizing as needed the LHS if (CalculateStiffnessMatrixFlag == true) //calculation of the matrix is required { - if (rLeftHandSideMatrix.size1() != MatSize) + if (rLeftHandSideMatrix.size1() != mat_size) { - rLeftHandSideMatrix.resize(MatSize, MatSize, false); + rLeftHandSideMatrix.resize(mat_size, mat_size, false); } - noalias(rLeftHandSideMatrix) = ZeroMatrix(MatSize, MatSize); //resetting LHS + noalias(rLeftHandSideMatrix) = ZeroMatrix(mat_size, mat_size); //resetting LHS } // Resizing as needed the RHS if (CalculateResidualVectorFlag == true) //calculation of the matrix is required { - if (rRightHandSideVector.size() != MatSize) + if (rRightHandSideVector.size() != mat_size) { - rRightHandSideVector.resize(MatSize, false); + rRightHandSideVector.resize(mat_size, false); } - rRightHandSideVector = ZeroVector(MatSize); //resetting RHS + rRightHandSideVector = ZeroVector(mat_size); //resetting RHS } // Reading integration points and local gradients IntegrationMethod integration_method = IntegrationUtilities::GetIntegrationMethodForExactMassMatrixEvaluation(GetGeometry()); - const GeometryType::IntegrationPointsArrayType& IntegrationPoints = GetGeometry().IntegrationPoints(integration_method); + const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints(integration_method); const GeometryType::ShapeFunctionsGradientsType& DN_DeContainer = GetGeometry().ShapeFunctionsLocalGradients(integration_method); const Matrix& Ncontainer = GetGeometry().ShapeFunctionsValues(integration_method); @@ -224,68 +225,64 @@ namespace Kratos J = GetGeometry().Jacobian(J,integration_method); // Vector with a loading applied to the elemnt - array_1d SurfaceLoad = ZeroVector(3); + array_1d surface_load = ZeroVector(3); if( this->Has( SURFACE_LOAD ) ) { - noalias(SurfaceLoad) = this->GetValue( SURFACE_LOAD ); + noalias(surface_load) = this->GetValue( SURFACE_LOAD ); } // Pressure applied to the element itself - double PressureOnCondition = 0.0; + double pressure_on_condition = 0.0; if( this->Has( PRESSURE ) ) { - PressureOnCondition += this->GetValue( PRESSURE ); + pressure_on_condition += this->GetValue( PRESSURE ); } if( this->Has( NEGATIVE_FACE_PRESSURE ) ) { - PressureOnCondition += this->GetValue( NEGATIVE_FACE_PRESSURE ); + pressure_on_condition += this->GetValue( NEGATIVE_FACE_PRESSURE ); } if( this->Has( POSITIVE_FACE_PRESSURE ) ) { - PressureOnCondition -= this->GetValue( POSITIVE_FACE_PRESSURE ); + pressure_on_condition -= this->GetValue( POSITIVE_FACE_PRESSURE ); } // Auxiliary terms - array_1d BodyForce; - Vector PressureOnNodes(NumberOfNodes, PressureOnCondition); //note that here we initialize from the value applied to the condition + Vector pressure_on_nodes(number_of_nodes, pressure_on_condition); //note that here we initialize from the value applied to the condition - for (unsigned int i = 0; i < PressureOnNodes.size(); i++) + for (unsigned int i = 0; i < pressure_on_nodes.size(); i++) { if( GetGeometry()[i].SolutionStepsDataHas( NEGATIVE_FACE_PRESSURE) ) { - PressureOnNodes[i] += GetGeometry()[i].FastGetSolutionStepValue( NEGATIVE_FACE_PRESSURE ); + pressure_on_nodes[i] += GetGeometry()[i].FastGetSolutionStepValue( NEGATIVE_FACE_PRESSURE ); } if( GetGeometry()[i].SolutionStepsDataHas( POSITIVE_FACE_PRESSURE) ) { - PressureOnNodes[i] -= GetGeometry()[i].FastGetSolutionStepValue( POSITIVE_FACE_PRESSURE ); + pressure_on_nodes[i] -= GetGeometry()[i].FastGetSolutionStepValue( POSITIVE_FACE_PRESSURE ); } } - array_1d ge; - array_1d gn; - array_1d v3; + array_1d ge, gn; - for (unsigned int PointNumber = 0; PointNumber < IntegrationPoints.size(); PointNumber++) + for (unsigned int point_number = 0; point_number < integration_points.size(); point_number++) { - const double detJ = MathUtils::GeneralizedDet(J[PointNumber]); - const double IntegrationWeight = GetIntegrationWeight(IntegrationPoints, PointNumber, detJ); - auto& N = row(Ncontainer, PointNumber); - - ge[0] = J[PointNumber](0, 0); - gn[0] = J[PointNumber](0, 1); - ge[1] = J[PointNumber](1, 0); - gn[1] = J[PointNumber](1, 1); - ge[2] = J[PointNumber](2, 0); - gn[2] = J[PointNumber](2, 1); - - MathUtils::CrossProduct(v3, ge, gn); - v3 /= norm_2(v3); - + const double det_j = MathUtils::GeneralizedDet(J[point_number]); + const double integration_weight = GetIntegrationWeight(integration_points, point_number, det_j); + auto& N = row(Ncontainer, point_number); + + ge[0] = J[point_number](0, 0); + gn[0] = J[point_number](0, 1); + ge[1] = J[point_number](1, 0); + gn[1] = J[point_number](1, 1); + ge[2] = J[point_number](2, 0); + gn[2] = J[point_number](2, 1); + + const array_1d normal = MathUtils::UnitCrossProduct(ge, gn); + // Calculating the pressure on the gauss point double pressure = 0.0; - for (unsigned int ii = 0; ii < NumberOfNodes; ii++) + for (unsigned int ii = 0; ii < number_of_nodes; ii++) { - pressure += N[ii] * PressureOnNodes[ii]; + pressure += N[ii] * pressure_on_nodes[ii]; } // LEFT HAND SIDE MATRIX @@ -293,7 +290,7 @@ namespace Kratos { if (pressure != 0.0) { - CalculateAndSubKp(rLeftHandSideMatrix, ge, gn, DN_DeContainer[PointNumber], N, pressure, IntegrationWeight); + CalculateAndSubKp(rLeftHandSideMatrix, ge, gn, DN_DeContainer[point_number], N, pressure, integration_weight); } } @@ -302,26 +299,26 @@ namespace Kratos { if (pressure != 0.0) { - CalculateAndAddPressureForce(rRightHandSideVector, N, v3, pressure, IntegrationWeight, rCurrentProcessInfo); + CalculateAndAddPressureForce(rRightHandSideVector, N, normal, pressure, integration_weight, rCurrentProcessInfo); } } //generic load on gauss point - array_1d GaussLoad = SurfaceLoad; - for (unsigned int ii = 0; ii < NumberOfNodes; ++ii) + array_1d gauss_load = surface_load; + for (unsigned int ii = 0; ii < number_of_nodes; ++ii) { if( GetGeometry()[ii].SolutionStepsDataHas( SURFACE_LOAD ) ) { - noalias(GaussLoad) += N[ii]*GetGeometry()[ii].FastGetSolutionStepValue( SURFACE_LOAD ); + noalias(gauss_load) += N[ii]*GetGeometry()[ii].FastGetSolutionStepValue( SURFACE_LOAD ); } } - for (unsigned int ii = 0; ii < NumberOfNodes; ++ii) + for (unsigned int ii = 0; ii < number_of_nodes; ++ii) { const unsigned int base = ii * 3; for(unsigned int k = 0; k < 3; ++k) { - rRightHandSideVector[base+k] += IntegrationWeight * N[ii] * GaussLoad[k]; + rRightHandSideVector[base+k] += integration_weight * N[ii] * gauss_load[k]; } } } diff --git a/applications/StructuralMechanicsApplication/custom_conditions/surface_load_condition_3d.h b/applications/StructuralMechanicsApplication/custom_conditions/surface_load_condition_3d.h index 3a522a866a1c..6226b607d965 100644 --- a/applications/StructuralMechanicsApplication/custom_conditions/surface_load_condition_3d.h +++ b/applications/StructuralMechanicsApplication/custom_conditions/surface_load_condition_3d.h @@ -154,25 +154,25 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) SurfaceLoadCondition3D void CalculateAndSubKp( Matrix& K, - array_1d& ge, - array_1d& gn, + const array_1d& ge, + const array_1d& gn, const Matrix& DN_De, const Vector& N, - double pressure, - double weight ); + const double Pressure, + const double Weight ); void MakeCrossMatrix( bounded_matrix& M, - array_1d& U + const array_1d& U ); void CalculateAndAddPressureForce( - VectorType& residualvector, + VectorType& rResidualVector, const Vector& N, - const array_1d& v3, - double pressure, - double weight, - const ProcessInfo& rCurrentProcessInfo + const array_1d& Normal, + const double Pressure, + const double Weight, + const ProcessInfo& rCurrentProcessInfo ); ///@} diff --git a/applications/StructuralMechanicsApplication/custom_constitutive/elastic_isotropic_3d.cpp b/applications/StructuralMechanicsApplication/custom_constitutive/elastic_isotropic_3d.cpp index cb2b1c58b7ad..c28883e043ac 100644 --- a/applications/StructuralMechanicsApplication/custom_constitutive/elastic_isotropic_3d.cpp +++ b/applications/StructuralMechanicsApplication/custom_constitutive/elastic_isotropic_3d.cpp @@ -69,7 +69,7 @@ void ElasticIsotropic3D::CalculateMaterialResponsePK2(ConstitutiveLaw::Paramete const double& NU = MaterialProperties[POISSON_RATIO]; //NOTE: SINCE THE ELEMENT IS IN SMALL STRAINS WE CAN USE ANY STRAIN MEASURE. HERE EMPLOYING THE CAUCHY_GREEN - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { CalculateCauchyGreenStrain(rValues, StrainVector); } @@ -96,48 +96,89 @@ void ElasticIsotropic3D::CalculateMaterialResponsePK2(ConstitutiveLaw::Paramete { CalculatePK2Stress( StrainVector, StressVector, E, NU ); } - } } +//************************************************************************************ +//************************************************************************************ + // NOTE: Since we are in the hypothesis of small strains we can use the same function for everything + void ElasticIsotropic3D::CalculateMaterialResponsePK1 (Parameters& rValues) { CalculateMaterialResponsePK2(rValues); } -// NOTE: Since we are in the hypothesis of small strains we can use the same function for everything +//************************************************************************************ +//************************************************************************************ + void ElasticIsotropic3D::CalculateMaterialResponseKirchhoff (Parameters& rValues) { CalculateMaterialResponsePK2(rValues); } -// NOTE: Since we are in the hypothesis of small strains we can use the same function for everything +//************************************************************************************ +//************************************************************************************ + void ElasticIsotropic3D::CalculateMaterialResponseCauchy (Parameters& rValues) { CalculateMaterialResponsePK2(rValues); } +//************************************************************************************ +//************************************************************************************ + void ElasticIsotropic3D::FinalizeMaterialResponsePK1(Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + void ElasticIsotropic3D::FinalizeMaterialResponsePK2(Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + void ElasticIsotropic3D::FinalizeMaterialResponseCauchy(Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + void ElasticIsotropic3D::FinalizeMaterialResponseKirchhoff(Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + +double& ElasticIsotropic3D::CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, double& rValue) +{ + const Properties& MaterialProperties = rParameterValues.GetMaterialProperties(); + Vector& StrainVector = rParameterValues.GetStrainVector(); + Vector& StressVector = rParameterValues.GetStressVector(); + const double& E = MaterialProperties[YOUNG_MODULUS]; + const double& NU = MaterialProperties[POISSON_RATIO]; + + if (rThisVariable == STRAIN_ENERGY) + { + CalculateCauchyGreenStrain(rParameterValues, StrainVector); + CalculatePK2Stress( StrainVector, StressVector, E, NU ); + + rValue = 0.5 * inner_prod(StrainVector,StressVector); // Strain energy = 0.5*E:C:E + } + + return( rValue ); +} + //*************************CONSTITUTIVE LAW GENERAL FEATURES ************************* //************************************************************************************ diff --git a/applications/StructuralMechanicsApplication/custom_constitutive/elastic_isotropic_3d.h b/applications/StructuralMechanicsApplication/custom_constitutive/elastic_isotropic_3d.h index a0193b0a6bde..6b586bf4b3ee 100644 --- a/applications/StructuralMechanicsApplication/custom_constitutive/elastic_isotropic_3d.h +++ b/applications/StructuralMechanicsApplication/custom_constitutive/elastic_isotropic_3d.h @@ -161,6 +161,15 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) ElasticIsotropic3D : public C */ void FinalizeMaterialResponseCauchy (Parameters & rValues) override; + /** + * calculates the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ + double& CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, double& rValue) override; + /** * This function provides the place to perform checks on the completeness of the input. * It is designed to be called only once (or anyway, not often) typically at the beginning @@ -184,7 +193,7 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) ElasticIsotropic3D : public C ///@} ///@name Protected member Variables ///@{ - + ///@} ///@name Protected Operators ///@{ diff --git a/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_strain.cpp b/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_strain.cpp index c5037e549547..c9a862d39a25 100644 --- a/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_strain.cpp +++ b/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_strain.cpp @@ -67,7 +67,7 @@ void LinearPlaneStrain::CalculateMaterialResponsePK2 (Parameters& rValues) const double& NU = MaterialProperties[POISSON_RATIO]; //NOTE: SINCE THE ELEMENT IS IN SMALL STRAINS WE CAN USE ANY STRAIN MEASURE. HERE EMPLOYING THE CAUCHY_GREEN - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { CalculateCauchyGreenStrain(rValues, StrainVector); } @@ -94,10 +94,12 @@ void LinearPlaneStrain::CalculateMaterialResponsePK2 (Parameters& rValues) { CalculatePK2Stress( StrainVector, StressVector, E, NU ); } - } } +//************************************************************************************ +//************************************************************************************ + //NOTE: Note that since we are in the hypothesis of small strains we can use the same function for everything void LinearPlaneStrain::CalculateMaterialResponseKirchhoff (Parameters& rValues) @@ -105,36 +107,76 @@ void LinearPlaneStrain::CalculateMaterialResponseKirchhoff (Parameters& rValues) CalculateMaterialResponsePK2(rValues); } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStrain::CalculateMaterialResponsePK1 (Parameters& rValues) { CalculateMaterialResponsePK2(rValues); } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStrain::CalculateMaterialResponseCauchy (Parameters& rValues) { CalculateMaterialResponsePK2(rValues); } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStrain::FinalizeMaterialResponsePK2 (Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStrain::FinalizeMaterialResponseKirchhoff (Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStrain::FinalizeMaterialResponsePK1 (Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStrain::FinalizeMaterialResponseCauchy (Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + +double& LinearPlaneStrain::CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, double& rValue) +{ + const Properties& MaterialProperties = rParameterValues.GetMaterialProperties(); + Vector& StrainVector = rParameterValues.GetStrainVector(); + Vector& StressVector = rParameterValues.GetStressVector(); + const double& E = MaterialProperties[YOUNG_MODULUS]; + const double& NU = MaterialProperties[POISSON_RATIO]; + + if (rThisVariable == STRAIN_ENERGY) + { + CalculateCauchyGreenStrain(rParameterValues, StrainVector); + CalculatePK2Stress( StrainVector, StressVector, E, NU ); + + rValue = 0.5 * inner_prod(StrainVector,StressVector); // Strain energy = 0.5*E:C:E + } + + return( rValue ); +} + //*************************CONSTITUTIVE LAW GENERAL FEATURES ************************* //************************************************************************************ @@ -157,6 +199,9 @@ void LinearPlaneStrain::GetLawFeatures(Features& rFeatures) } +//************************************************************************************ +//************************************************************************************ + int LinearPlaneStrain::Check(const Properties& rMaterialProperties, const GeometryType& rElementGeometry, const ProcessInfo& rCurrentProcessInfo) @@ -183,8 +228,6 @@ int LinearPlaneStrain::Check(const Properties& rMaterialProperties, return 0; - } - } // Namespace Kratos diff --git a/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_strain.h b/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_strain.h index 83537395349a..4f7b0b2be09c 100644 --- a/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_strain.h +++ b/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_strain.h @@ -80,7 +80,6 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) LinearPlaneStrain : public Co SizeType GetStrainSize() override { return 3; - } /** @@ -147,6 +146,15 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) LinearPlaneStrain : public Co */ void FinalizeMaterialResponseCauchy (Parameters & rValues) override; + /** + * calculates the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ + double& CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, double& rValue) override; + /** * This function provides the place to perform checks on the completeness of the input. * It is designed to be called only once (or anyway, not often) typically at the beginning @@ -167,28 +175,29 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) LinearPlaneStrain : public Co ///@name Protected static Member Variables ///@{ + ///@} ///@name Protected member Variables ///@{ + ///@} ///@name Protected Operators ///@{ + ///@} ///@name Protected Operations ///@{ ///@} - private: - ///@name Static Member Variables ///@{ + ///@} ///@name Member Variables ///@{ - ///@} ///@name Private Operators ///@{ diff --git a/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_stress.cpp b/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_stress.cpp index 08ab5ce8a5fa..dbc2f6374307 100644 --- a/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_stress.cpp +++ b/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_stress.cpp @@ -55,6 +55,9 @@ LinearPlaneStress::~LinearPlaneStress() { } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStress::CalculateMaterialResponsePK2 (Parameters& rValues) { //b.- Get Values to compute the constitutive law: @@ -67,7 +70,7 @@ void LinearPlaneStress::CalculateMaterialResponsePK2 (Parameters& rValues) const double& NU = MaterialProperties[POISSON_RATIO]; //NOTE: SINCE THE ELEMENT IS IN SMALL STRAINS WE CAN USE ANY STRAIN MEASURE. HERE EMPLOYING THE CAUCHY_GREEN - if(Options.Is( ConstitutiveLaw::COMPUTE_STRAIN )) + if(Options.Is( ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN )) { CalculateCauchyGreenStrain(rValues, StrainVector); } @@ -94,10 +97,12 @@ void LinearPlaneStress::CalculateMaterialResponsePK2 (Parameters& rValues) { CalculatePK2Stress( StrainVector, StressVector, E, NU ); } - } } +//************************************************************************************ +//************************************************************************************ + //NOTE: Note that since we are in the hypothesis of small strains we can use the same function for everything void LinearPlaneStress::CalculateMaterialResponseKirchhoff (Parameters& rValues) @@ -105,36 +110,76 @@ void LinearPlaneStress::CalculateMaterialResponseKirchhoff (Parameters& rValues) CalculateMaterialResponsePK2(rValues); } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStress::CalculateMaterialResponsePK1 (Parameters& rValues) { CalculateMaterialResponsePK2(rValues); } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStress::CalculateMaterialResponseCauchy (Parameters& rValues) { CalculateMaterialResponsePK2(rValues); } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStress::FinalizeMaterialResponsePK1(Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStress::FinalizeMaterialResponsePK2(Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStress::FinalizeMaterialResponseCauchy(Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + void LinearPlaneStress::FinalizeMaterialResponseKirchhoff(Parameters& rValues) { // TODO: Add if necessary } +//************************************************************************************ +//************************************************************************************ + +double& LinearPlaneStress::CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, double& rValue) +{ + const Properties& MaterialProperties = rParameterValues.GetMaterialProperties(); + Vector& StrainVector = rParameterValues.GetStrainVector(); + Vector& StressVector = rParameterValues.GetStressVector(); + const double& E = MaterialProperties[YOUNG_MODULUS]; + const double& NU = MaterialProperties[POISSON_RATIO]; + + if (rThisVariable == STRAIN_ENERGY) + { + CalculateCauchyGreenStrain(rParameterValues, StrainVector); + CalculatePK2Stress( StrainVector, StressVector, E, NU ); + + rValue = 0.5 * inner_prod(StrainVector,StressVector); // Strain energy = 0.5*E:C:E + } + + return( rValue ); +} + //*************************CONSTITUTIVE LAW GENERAL FEATURES ************************* //************************************************************************************ @@ -154,7 +199,6 @@ void LinearPlaneStress::GetLawFeatures(Features& rFeatures) //Set the spacedimension rFeatures.mSpaceDimension = 2; - } int LinearPlaneStress::Check( diff --git a/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_stress.h b/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_stress.h index b29853b1ef08..6f9bf6da4ec5 100644 --- a/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_stress.h +++ b/applications/StructuralMechanicsApplication/custom_constitutive/linear_plane_stress.h @@ -147,6 +147,15 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) LinearPlaneStress : public Co */ void FinalizeMaterialResponseCauchy (Parameters & rValues) override; + /** + * calculates the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ + double& CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, double& rValue) override; + /** * This function provides the place to perform checks on the completeness of the input. * It is designed to be called only once (or anyway, not often) typically at the beginning @@ -162,34 +171,33 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) LinearPlaneStress : public Co const ProcessInfo& rCurrentProcessInfo ) override; - - protected: ///@name Protected static Member Variables ///@{ + ///@} ///@name Protected member Variables ///@{ + ///@} ///@name Protected Operators ///@{ + ///@} ///@name Protected Operations ///@{ ///@} - private: - ///@name Static Member Variables ///@{ + ///@} ///@name Member Variables ///@{ - ///@} ///@name Private Operators ///@{ @@ -216,11 +224,9 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) LinearPlaneStress : public Co double c2 = c1 * NU; double c3 = 0.5* E / (1 + NU); - StressVector[0] = c1*StrainVector[0] + c2 * (StrainVector[1]) ; StressVector[1] = c1*StrainVector[1] + c2 * (StrainVector[0]) ; StressVector[2] = c3*StrainVector[2]; - } void CalculateCauchyGreenStrain( @@ -238,7 +244,6 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) LinearPlaneStress : public Co noalias(StrainVector) = MathUtils::StrainTensorToVector(Etensor); } - ///@} ///@name Private Operations ///@{ diff --git a/applications/StructuralMechanicsApplication/custom_elements/SprismElement3D6N.cpp b/applications/StructuralMechanicsApplication/custom_elements/SprismElement3D6N.cpp index dec7cd9a0e11..b0b77e62c08a 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/SprismElement3D6N.cpp +++ b/applications/StructuralMechanicsApplication/custom_elements/SprismElement3D6N.cpp @@ -861,7 +861,7 @@ void SprismElement3D6N::CalculateOnIntegrationPoints( /* Set constitutive law flags: */ Flags &ConstitutiveLawOptions = Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS); /* Reading integration points */ @@ -929,7 +929,7 @@ void SprismElement3D6N::CalculateOnIntegrationPoints( // Set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, true); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY, true); @@ -990,7 +990,7 @@ void SprismElement3D6N::CalculateOnIntegrationPoints( // Set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, true); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN_ENERGY, true); @@ -1101,7 +1101,7 @@ void SprismElement3D6N::CalculateOnIntegrationPoints( // Set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, true); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); /* Reading integration points */ @@ -1843,7 +1843,7 @@ void SprismElement3D6N::FinalizeSolutionStep(ProcessInfo& rCurrentProcessInfo) // Get constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, true); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); const GeometryType::IntegrationPointsArrayType& IntegrationPoints = GetGeometry().IntegrationPoints( mThisIntegrationMethod ); @@ -2027,7 +2027,7 @@ void SprismElement3D6N::CalculateElementalSystem( /* Set constitutive law flags: */ Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, true); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, true); diff --git a/applications/StructuralMechanicsApplication/custom_elements/base_solid_element.cpp b/applications/StructuralMechanicsApplication/custom_elements/base_solid_element.cpp index 0c3bd009130d..09b9921863e4 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/base_solid_element.cpp +++ b/applications/StructuralMechanicsApplication/custom_elements/base_solid_element.cpp @@ -90,7 +90,7 @@ namespace Kratos // Set constitutive law flags: Flags& ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, false); @@ -534,6 +534,54 @@ namespace Kratos rOutput[point_number] = integration_weight; } } + else if ( rVariable == STRAIN_ENERGY ) + { + const unsigned int number_of_nodes = GetGeometry().size(); + const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); + const unsigned int strain_size = mConstitutiveLawVector[0]->GetStrainSize(); + + KinematicVariables this_kinematic_variables(strain_size, dimension, number_of_nodes); + ConstitutiveVariables this_constitutive_variables(strain_size); + + // Create constitutive law parameters: + ConstitutiveLaw::Parameters Values(GetGeometry(),GetProperties(),rCurrentProcessInfo); + + // Reading integration points + const GeometryType::IntegrationPointsArrayType& integration_points = GetGeometry().IntegrationPoints( ); + + // If strain has to be computed inside of the constitutive law with PK2 + Values.SetStrainVector(this_constitutive_variables.StrainVector); //this is the input parameter + + // Displacements vector + Vector displacements; + GetValuesVector(displacements); + + for (unsigned int point_number = 0; point_number < integration_points.size(); point_number++) + { + // Compute element kinematics B, F, DN_DX ... + CalculateKinematicVariables(this_kinematic_variables, point_number, integration_points); + + // Compute material reponse + CalculateConstitutiveVariables(this_kinematic_variables, this_constitutive_variables, Values, point_number, integration_points, GetStressMeasure(), displacements); + + double integration_weight = GetIntegrationWeight(integration_points, + point_number, + this_kinematic_variables.detJ0); + + if (dimension == 2 && this->GetProperties().Has(THICKNESS)) + { + integration_weight *= this->GetProperties()[THICKNESS]; + } + + double StrainEnergy = 0.0; + + // Compute stresses and constitutive parameters + mConstitutiveLawVector[point_number]->CalculateMaterialResponse(Values, GetStressMeasure()); + mConstitutiveLawVector[point_number]->CalculateValue(Values, STRAIN_ENERGY, StrainEnergy); + + rOutput[point_number] = integration_weight * StrainEnergy; // 1/2 * sigma * epsilon + } + } else if (rVariable == VON_MISES_STRESS) { const unsigned int number_of_nodes = GetGeometry().size(); @@ -548,7 +596,7 @@ namespace Kratos // Set constitutive law flags: Flags& ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, false); @@ -606,6 +654,40 @@ namespace Kratos } } } + + //************************************************************************************ + //************************************************************************************ + + void BaseSolidElement::CalculateOnIntegrationPoints( + const Variable>& rVariable, + std::vector>& rOutput, + const ProcessInfo& rCurrentProcessInfo + ) + { + const GeometryType::IntegrationPointsArrayType &integration_points = GetGeometry().IntegrationPoints(); + + if ( rOutput.size() != GetGeometry().IntegrationPoints( ).size() ) + { + rOutput.resize( GetGeometry().IntegrationPoints( ).size() ); + } + + if (rVariable == INTEGRATION_COORDINATES) + { + const unsigned int number_of_nodes = GetGeometry().size(); + const unsigned int dimension = GetGeometry().WorkingSpaceDimension(); + const unsigned int strain_size = mConstitutiveLawVector[0]->GetStrainSize(); + + KinematicVariables this_kinematic_variables(strain_size, dimension, number_of_nodes); + + for (unsigned int point_number = 0; point_number < integration_points.size(); point_number++) + { + Point<3> global_point; + GetGeometry().GlobalCoordinates(global_point, integration_points[point_number]); + + rOutput[point_number] = global_point.Coordinates(); + } + } + } //************************************************************************************ //************************************************************************************ @@ -651,7 +733,7 @@ namespace Kratos // Set constitutive law flags: Flags& ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, false); @@ -705,7 +787,7 @@ namespace Kratos // Set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, true); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, false); @@ -826,7 +908,7 @@ namespace Kratos // Set constitutive law flags: Flags& ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, true); @@ -965,6 +1047,18 @@ namespace Kratos //************************************************************************************ //************************************************************************************ + void BaseSolidElement::GetValueOnIntegrationPoints( + const Variable>& rVariable, + std::vector>& rValues, + const ProcessInfo& rCurrentProcessInfo + ) + { + CalculateOnIntegrationPoints( rVariable, rValues, rCurrentProcessInfo ); + } + + //************************************************************************************ + //************************************************************************************ + void BaseSolidElement::GetValueOnIntegrationPoints( const Variable& rVariable, std::vector& rValues, diff --git a/applications/StructuralMechanicsApplication/custom_elements/base_solid_element.h b/applications/StructuralMechanicsApplication/custom_elements/base_solid_element.h index b0be8b2787f2..d0c2f0cf0301 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/base_solid_element.h +++ b/applications/StructuralMechanicsApplication/custom_elements/base_solid_element.h @@ -287,6 +287,18 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) BaseSolidElement std::vector& rOutput, const ProcessInfo& rCurrentProcessInfo ) override; + + /** + * Calculate a double array_1d on the Element Constitutive Law + * @param rVariable: The variable we want to get + * @param rOutput: The values obtained int the integration points + * @param rCurrentProcessInfo: the current process info instance + */ + void CalculateOnIntegrationPoints( + const Variable>& rVariable, + std::vector>& rOutput, + const ProcessInfo& rCurrentProcessInfo + ) override; /** * Calculate a Vector Variable on the Element Constitutive Law @@ -360,6 +372,18 @@ class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) BaseSolidElement const ProcessInfo& rCurrentProcessInfo ) override; + /** + * Get on rVariable a array_1d Value from the Element Constitutive Law + * @param rVariable: The variable we want to get + * @param rValues: The results in the integration points + * @param rCurrentProcessInfo: the current process info instance + */ + void GetValueOnIntegrationPoints( + const Variable>& rVariable, + std::vector>& rValues, + const ProcessInfo& rCurrentProcessInfo + ) override; + /** * Get on rVariable a Vector Value from the Element Constitutive Law * @param rVariable: The variable we want to get diff --git a/applications/StructuralMechanicsApplication/custom_elements/cr_beam_element_3D2N.cpp b/applications/StructuralMechanicsApplication/custom_elements/cr_beam_element_3D2N.cpp index dae8c8b874ed..485ff771da1d 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/cr_beam_element_3D2N.cpp +++ b/applications/StructuralMechanicsApplication/custom_elements/cr_beam_element_3D2N.cpp @@ -130,10 +130,10 @@ namespace Kratos const double A = this->GetProperties()[CROSS_AREA]; const double L = this->CalculateReferenceLength(); - const double J = this->GetProperties()[IT]; - const double Iy = this->GetProperties()[IY]; - const double Iz = this->GetProperties()[IZ]; - + Vector inertia = this->GetProperties()[LOCAL_INERTIA_VECTOR]; + const double J = inertia[0]; + const double Iy = inertia[1]; + const double Iz = inertia[2]; double Ay = 0.00; if (this->GetProperties().Has(AREA_EFFECTIVE_Y) == true) { @@ -344,9 +344,11 @@ namespace Kratos const double G = this->CalculateShearModulus(); const double A = this->GetProperties()[CROSS_AREA]; const double L = this->CalculateReferenceLength(); - const double J = this->GetProperties()[IT]; - const double Iy = this->GetProperties()[IY]; - const double Iz = this->GetProperties()[IZ]; + + Vector inertia = this->GetProperties()[LOCAL_INERTIA_VECTOR]; + const double J = inertia[0]; + const double Iy = inertia[1]; + const double Iz = inertia[2]; double Ay = 0.00; if (this->GetProperties().Has(AREA_EFFECTIVE_Y) == true) { @@ -1515,8 +1517,10 @@ namespace Kratos const double rho = this->GetProperties()[DENSITY]; const double A = this->GetProperties()[CROSS_AREA]; const double E = this->GetProperties()[YOUNG_MODULUS]; - const double Iy = this->GetProperties()[IY]; - const double Iz = this->GetProperties()[IZ]; + Vector inertia = this->GetProperties()[LOCAL_INERTIA_VECTOR]; + const double J = inertia[0]; + const double Iy = inertia[1]; + const double Iz = inertia[2]; const double G = this->CalculateShearModulus(); double Ay = 0.00; @@ -1554,12 +1558,15 @@ namespace Kratos //longitudinal forces + torsional moment const double M00 = (1.00 / 3.00)*A*rho*L; const double M06 = M00 / 2.00; + const double M33 = (J*L*rho) / 3.00; + const double M39 = M33 / 2.00; + rMassMatrix(0, 0) = M00; rMassMatrix(0, 6) = M06; rMassMatrix(6, 6) = M00; - rMassMatrix(3, 3) = M00; - rMassMatrix(3, 9) = M06; - rMassMatrix(9, 9) = M00; + rMassMatrix(3, 3) = M33; + rMassMatrix(3, 9) = M39; + rMassMatrix(9, 9) = M33; Matrix TempBendingMassMatrix = ZeroMatrix(smallMatSize, smallMatSize); this->BuildSingleMassMatrix(TempBendingMassMatrix, Phiz, CTz, CRz, L); @@ -1785,21 +1792,9 @@ namespace Kratos << std::endl; } - if (this->GetProperties().Has(IT) == false) - { - KRATOS_ERROR << "IT not provided for this element" << this->Id() - << std::endl; - } - - if (this->GetProperties().Has(IY) == false) - { - KRATOS_ERROR << "IY not provided for this element" << this->Id() - << std::endl; - } - - if (this->GetProperties().Has(IZ) == false) + if (this->GetProperties().Has(LOCAL_INERTIA_VECTOR) == false) { - KRATOS_ERROR << "IZ not provided for this element" << this->Id() + KRATOS_ERROR << "LOCAL_INERTIA_VECTOR not provided for this element" << this->Id() << std::endl; } diff --git a/applications/StructuralMechanicsApplication/custom_elements/membrane_element.cpp b/applications/StructuralMechanicsApplication/custom_elements/membrane_element.cpp index c6b2e942cd96..a076b8a5cd5b 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/membrane_element.cpp +++ b/applications/StructuralMechanicsApplication/custom_elements/membrane_element.cpp @@ -301,7 +301,7 @@ void MembraneElement::CalculateOnIntegrationPoints( CalculateStrain( StrainVector, C ); ConstitutiveLaw::Parameters Values(GetGeometry(),GetProperties(),rCurrentProcessInfo); - Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + Values.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRESS); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, false); @@ -479,7 +479,7 @@ void MembraneElement::FinalizeSolutionStep( { // // ConstitutiveLaw::Parameters Values (GetGeometry(),GetProperties(),rCurrentProcessInfo); -// Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRAIN, false); +// Values.GetOptions().Set (ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRESS); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); // Matrix dummy = ZeroMatrix ( 0, 0 ); @@ -1058,7 +1058,7 @@ void MembraneElement::CalculateAll( ConstitutiveLaw::Parameters Values(GetGeometry(),GetProperties(),rCurrentProcessInfo); - Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + Values.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRESS); Values.GetOptions().Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); diff --git a/applications/StructuralMechanicsApplication/custom_elements/prestress_membrane_element.cpp b/applications/StructuralMechanicsApplication/custom_elements/prestress_membrane_element.cpp index 00bcdaf83705..2f8036183352 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/prestress_membrane_element.cpp +++ b/applications/StructuralMechanicsApplication/custom_elements/prestress_membrane_element.cpp @@ -393,7 +393,7 @@ void PrestressMembraneElement::FinalizeSolutionStep( { // // ConstitutiveLaw::Parameters Values (GetGeometry(),GetProperties(),rCurrentProcessInfo); - // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRAIN, false); + // Values.GetOptions().Set (ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_STRESS); // Values.GetOptions().Set (ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR); // Matrix dummy = ZeroMatrix ( 0, 0 ); @@ -794,7 +794,7 @@ void PrestressMembraneElement::CalculateAll( // Set constitutive law flags: Flags &ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, true); diff --git a/applications/StructuralMechanicsApplication/custom_elements/small_displacement.cpp b/applications/StructuralMechanicsApplication/custom_elements/small_displacement.cpp index ff2ffc50f325..0b9876f4aaa3 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/small_displacement.cpp +++ b/applications/StructuralMechanicsApplication/custom_elements/small_displacement.cpp @@ -98,7 +98,7 @@ namespace Kratos // Set constitutive law flags: Flags& ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, true); diff --git a/applications/StructuralMechanicsApplication/custom_elements/small_displacement.h b/applications/StructuralMechanicsApplication/custom_elements/small_displacement.h index 30349ed63200..583af5a26a5f 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/small_displacement.h +++ b/applications/StructuralMechanicsApplication/custom_elements/small_displacement.h @@ -55,7 +55,7 @@ namespace Kratos * This works for arbitrary geometries in 2D and 3D */ -class SmallDisplacement +class KRATOS_API(STRUCTURAL_MECHANICS_APPLICATION) SmallDisplacement : public BaseSolidElement { public: diff --git a/applications/StructuralMechanicsApplication/custom_elements/total_lagrangian.cpp b/applications/StructuralMechanicsApplication/custom_elements/total_lagrangian.cpp index 6a618682fc66..f9f195857176 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/total_lagrangian.cpp +++ b/applications/StructuralMechanicsApplication/custom_elements/total_lagrangian.cpp @@ -100,7 +100,7 @@ namespace Kratos // Set constitutive law flags: Flags& ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, true); diff --git a/applications/StructuralMechanicsApplication/custom_elements/updated_lagrangian.cpp b/applications/StructuralMechanicsApplication/custom_elements/updated_lagrangian.cpp index 852f6187333a..24a3d1a34573 100644 --- a/applications/StructuralMechanicsApplication/custom_elements/updated_lagrangian.cpp +++ b/applications/StructuralMechanicsApplication/custom_elements/updated_lagrangian.cpp @@ -117,7 +117,7 @@ namespace Kratos // Set constitutive law flags: Flags& ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, false); @@ -224,7 +224,7 @@ namespace Kratos // Set constitutive law flags: Flags& ConstitutiveLawOptions=Values.GetOptions(); - ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + ConstitutiveLawOptions.Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_STRESS, true); ConstitutiveLawOptions.Set(ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR, true); diff --git a/applications/StructuralMechanicsApplication/custom_python/structural_mechanics_python_application.cpp b/applications/StructuralMechanicsApplication/custom_python/structural_mechanics_python_application.cpp index 985f8a40fee3..a355d9c7f2fe 100644 --- a/applications/StructuralMechanicsApplication/custom_python/structural_mechanics_python_application.cpp +++ b/applications/StructuralMechanicsApplication/custom_python/structural_mechanics_python_application.cpp @@ -69,10 +69,12 @@ BOOST_PYTHON_MODULE(KratosStructuralMechanicsApplication) KRATOS_REGISTER_IN_PYTHON_VARIABLE(INERTIA_ROT_Z) KRATOS_REGISTER_IN_PYTHON_VARIABLE(LOCAL_AXES_VECTOR) KRATOS_REGISTER_IN_PYTHON_VARIABLE(LUMPED_MASS_MATRIX) + KRATOS_REGISTER_IN_PYTHON_VARIABLE(LOCAL_INERTIA_VECTOR) KRATOS_REGISTER_IN_PYTHON_VARIABLE(IT) KRATOS_REGISTER_IN_PYTHON_VARIABLE(IY) KRATOS_REGISTER_IN_PYTHON_VARIABLE(IZ) + // shell generalized variables KRATOS_REGISTER_IN_PYTHON_VARIABLE( SHELL_STRAIN ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( SHELL_STRAIN_GLOBAL ) diff --git a/applications/StructuralMechanicsApplication/custom_utilities/shell_cross_section.cpp b/applications/StructuralMechanicsApplication/custom_utilities/shell_cross_section.cpp index 7fe4850acd29..68ae08a2dd5f 100644 --- a/applications/StructuralMechanicsApplication/custom_utilities/shell_cross_section.cpp +++ b/applications/StructuralMechanicsApplication/custom_utilities/shell_cross_section.cpp @@ -799,7 +799,7 @@ void ShellCrossSection::InitializeParameters(Parameters& rValues, ConstitutiveLa // share common data between section and materials rMaterialValues.SetOptions(rValues.GetOptions()); - rMaterialValues.GetOptions().Set(ConstitutiveLaw::COMPUTE_STRAIN, false); + rMaterialValues.GetOptions().Set(ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN, false); rMaterialValues.SetShapeFunctionsValues( rValues.GetShapeFunctionsValues() ); rMaterialValues.SetShapeFunctionsDerivatives( rValues.GetShapeFunctionsDerivatives() ); diff --git a/applications/StructuralMechanicsApplication/python_scripts/Kratos_Main_Structural.py b/applications/StructuralMechanicsApplication/python_scripts/Kratos_Main_Structural.py deleted file mode 100755 index c43e391c4cb2..000000000000 --- a/applications/StructuralMechanicsApplication/python_scripts/Kratos_Main_Structural.py +++ /dev/null @@ -1,181 +0,0 @@ -from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 - -import KratosMultiphysics -import KratosMultiphysics.StructuralMechanicsApplication as StructuralMechanicsApplication -import KratosMultiphysics.ExternalSolversApplication as ExternalSolversApplication -import os - -#### TIME MONITORING START #### - -# time control starts -import time as timer -print(timer.ctime()) -# measure process time -t0p = timer.clock() -# measure wall time -t0w = timer.time() - -# -def StartTimeMeasuring(): - # measure process time - time_ip = timer.clock() - return time_ip - -def StopTimeMeasuring(time_ip, process, report): - # measure process time - time_fp = timer.clock() - if( report ): - used_time = time_fp - time_ip - print("::[KSM Simulation]:: [ %.2f" % round(used_time,2),"s", process," ] ") - -#### TIME MONITORING END #### - -#### PARSING THE PARAMETERS #### - -# Import define_output -parameter_file = open("ProjectParameters.json",'r') -ProjectParameters = KratosMultiphysics.Parameters( parameter_file.read()) - -# Set echo level -echo_level = ProjectParameters["problem_data"]["echo_level"].GetInt() - -#### Model_part settings start #### -# Defining the model_part -main_model_part = KratosMultiphysics.ModelPart(ProjectParameters["problem_data"]["model_part_name"].GetString()) -main_model_part.ProcessInfo.SetValue(KratosMultiphysics.DOMAIN_SIZE, ProjectParameters["problem_data"]["domain_size"].GetInt()) - -Model = {ProjectParameters["problem_data"]["model_part_name"].GetString(): main_model_part} - -# Construct the solver (main setting methods are located in the solver_module) -solver_module = __import__(ProjectParameters["solver_settings"]["solver_type"].GetString()) -solver = solver_module.CreateSolver(main_model_part, ProjectParameters["solver_settings"]) - -# Add variables (always before importing the model part) (it must be integrated in the ImportModelPart) -# If we integrate it in the model part we cannot use combined solvers -solver.AddVariables() - -# Read model_part (note: the buffer_size is set here) (restart can be read here) -solver.ImportModelPart() - -# Add dofs (always after importing the model part) (it must be integrated in the ImportModelPart) -# If we integrate it in the model part we cannot use combined solvers -solver.AddDofs() - -# Build sub_model_parts or submeshes (rearrange parts for the application of custom processes) -# #Get the list of the submodel part in the object Model -for i in range(ProjectParameters["solver_settings"]["processes_sub_model_part_list"].size()): - part_name = ProjectParameters["solver_settings"]["processes_sub_model_part_list"][i].GetString() - Model.update({part_name: main_model_part.GetSubModelPart(part_name)}) - -# Print model_part and properties -if(echo_level>1): - print("") - print(main_model_part) - for properties in main_model_part.Properties: - print(properties) - -# Obtain the list of the processes to be applied -import process_factory -list_of_processes = process_factory.KratosProcessFactory(Model).ConstructListOfProcesses(ProjectParameters["constraints_process_list"]) -list_of_processes += process_factory.KratosProcessFactory(Model).ConstructListOfProcesses(ProjectParameters["loads_process_list"]) -if (ProjectParameters.Has("list_other_processes") == True): - list_of_processes += process_factory.KratosProcessFactory(Model).ConstructListOfProcesses(ProjectParameters["list_other_processes"]) -if (ProjectParameters.Has("json_output_process") == True): - list_of_processes += process_factory.KratosProcessFactory(Model).ConstructListOfProcesses(ProjectParameters["json_output_process"]) - -for process in list_of_processes: - process.ExecuteInitialize() - -# ### START SOLUTION #### - -computing_model_part = solver.GetComputingModelPart() - -# ### Output settings start #### -problem_path = os.getcwd() -problem_name = ProjectParameters["problem_data"]["problem_name"].GetString() - -# ### Output settings start #### -output_post = ProjectParameters.Has("output_configuration") -if (output_post == True): - from gid_output_process import GiDOutputProcess - output_settings = ProjectParameters["output_configuration"] - gid_output = GiDOutputProcess(computing_model_part, - problem_name, - output_settings) - gid_output.ExecuteInitialize() - -# Sets strategies, builders, linear solvers, schemes and solving info, and fills the buffer -solver.Initialize() -solver.SetEchoLevel(echo_level) - -if (output_post == True): - gid_output.ExecuteBeforeSolutionLoop() - -for process in list_of_processes: - process.ExecuteBeforeSolutionLoop() - -# #Stepping and time settings (get from process info or solving info) -# Delta time -delta_time = ProjectParameters["problem_data"]["time_step"].GetDouble() -# Start step -main_model_part.ProcessInfo[KratosMultiphysics.TIME_STEPS] = 0 -# Start time -time = ProjectParameters["problem_data"]["start_time"].GetDouble() -# End time -end_time = ProjectParameters["problem_data"]["end_time"].GetDouble() - -# Solving the problem (time integration) -while(time <= end_time): - time = time + delta_time - main_model_part.ProcessInfo[KratosMultiphysics.TIME_STEPS] += 1 - main_model_part.CloneTimeStep(time) - - for process in list_of_processes: - process.ExecuteInitializeSolutionStep() - - if (output_post == True): - gid_output.ExecuteInitializeSolutionStep() - - solver.Solve() - - current_vals = [ev for ev in computing_model_part.ProcessInfo[StructuralMechanicsApplication.EIGENVALUE_VECTOR]] - print(current_vals) - - if (output_post == True): - gid_output.ExecuteFinalizeSolutionStep() - - for process in list_of_processes: - process.ExecuteFinalizeSolutionStep() - - for process in list_of_processes: - process.ExecuteBeforeOutputStep() - - for process in list_of_processes: - process.ExecuteAfterOutputStep() - - if (output_post == True): - if gid_output.IsOutputStep(): - gid_output.PrintOutput() - -if (output_post == True): - gid_output.ExecuteFinalize() - -for process in list_of_processes: - process.ExecuteFinalize() - -print("::[KSM Simulation]:: Analysis -END- ") -print(" ") - -# Check solving information for any problem -#~ solver.InfoCheck() # InfoCheck not implemented yet. - -#### END SOLUTION #### - -# measure process time -tfp = timer.clock() -# measure wall time -tfw = timer.time() - -print("::[KSM Simulation]:: [ Computing Time = (%.2f" % (tfp - t0p)," seconds process time) ( %.2f" % (tfw - t0w)," seconds wall time) ]") - -print(timer.ctime()) diff --git a/applications/StructuralMechanicsApplication/python_scripts/kratos_main_structural.py b/applications/StructuralMechanicsApplication/python_scripts/kratos_main_structural.py new file mode 100755 index 000000000000..45ed30c7966d --- /dev/null +++ b/applications/StructuralMechanicsApplication/python_scripts/kratos_main_structural.py @@ -0,0 +1,153 @@ +from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +from KratosMultiphysics import * +from KratosMultiphysics.ExternalSolversApplication import * +from KratosMultiphysics.StructuralMechanicsApplication import * + +## Import define_output +parameter_file = open("ProjectParameters.json",'r') +ProjectParameters = Parameters( parameter_file.read()) + +## Get echo level and parallel type +echo_level = ProjectParameters["problem_data"]["echo_level"].GetInt() +parallel_type = ProjectParameters["problem_data"]["parallel_type"].GetString() + +## Import parallel modules if needed +if (parallel_type == "MPI"): + from KratosMultiphysics.mpi import * + from KratosMultiphysics.MetisApplication import * + from KratosMultiphysics.TrilinosApplication import * + +## Structure model part definition +main_model_part = ModelPart(ProjectParameters["problem_data"]["model_part_name"].GetString()) +main_model_part.ProcessInfo.SetValue(DOMAIN_SIZE, ProjectParameters["problem_data"]["domain_size"].GetInt()) + +## Solver construction +import python_solvers_wrapper_structural +solver = python_solvers_wrapper_structural.CreateSolver(main_model_part, ProjectParameters) + +solver.AddVariables() + +## Read the model - note that SetBufferSize is done here +solver.ImportModelPart() + +## Add AddDofs +solver.AddDofs() + +## Initialize GiD I/O +output_post = ProjectParameters.Has("output_configuration") +if (output_post == True): + if (parallel_type == "OpenMP"): + from gid_output_process import GiDOutputProcess + gid_output = GiDOutputProcess(solver.GetComputingModelPart(), + ProjectParameters["problem_data"]["problem_name"].GetString() , + ProjectParameters["output_configuration"]) + elif (parallel_type == "MPI"): + from gid_output_process_mpi import GiDOutputProcessMPI + gid_output = GiDOutputProcessMPI(solver.GetComputingModelPart(), + ProjectParameters["problem_data"]["problem_name"].GetString() , + ProjectParameters["output_configuration"]) + + gid_output.ExecuteInitialize() + +## Creation of the Kratos model (build sub_model_parts or submeshes) +StructureModel = {ProjectParameters["problem_data"]["model_part_name"].GetString(): main_model_part} + +## Get the list of the sub_model_parts in where the processes are to be applied +for i in range(ProjectParameters["solver_settings"]["processes_sub_model_part_list"].size()): + part_name = ProjectParameters["solver_settings"]["processes_sub_model_part_list"][i].GetString() + StructureModel.update({part_name: main_model_part.GetSubModelPart(part_name)}) + +## Print model_part and properties +if ((parallel_type == "OpenMP") or (mpi.rank == 0)) and (echo_level > 1): + print("") + print(main_model_part) + for properties in main_model_part.Properties: + print(properties) + +## Processes construction +import process_factory +list_of_processes = process_factory.KratosProcessFactory(StructureModel).ConstructListOfProcesses(ProjectParameters["constraints_process_list"]) +list_of_processes += process_factory.KratosProcessFactory(StructureModel).ConstructListOfProcesses(ProjectParameters["loads_process_list"]) +if (ProjectParameters.Has("list_other_processes") == True): + list_of_processes += process_factory.KratosProcessFactory(StructureModel).ConstructListOfProcesses(ProjectParameters["list_other_processes"]) +if (ProjectParameters.Has("json_output_process") == True): + list_of_processes += process_factory.KratosProcessFactory(StructureModel).ConstructListOfProcesses(ProjectParameters["json_output_process"]) + +if ((parallel_type == "OpenMP") or (mpi.rank == 0)) and (echo_level > 1): + for process in list_of_processes: + print(process) + +## Processes initialization +for process in list_of_processes: + process.ExecuteInitialize() + +## Solver initialization +solver.Initialize() +solver.SetEchoLevel(echo_level) + +if (output_post == True): + gid_output.ExecuteBeforeSolutionLoop() + +for process in list_of_processes: + process.ExecuteBeforeSolutionLoop() + +## Writing the full ProjectParameters file before solving +if ((parallel_type == "OpenMP") or (mpi.rank == 0)) and (echo_level > 0): + f = open("ProjectParametersOutput.json", 'w') + f.write(ProjectParameters.PrettyPrintJsonString()) + f.close() + +## Stepping and time settings +delta_time = ProjectParameters["problem_data"]["time_step"].GetDouble() +start_time = ProjectParameters["problem_data"]["start_time"].GetDouble() +end_time = ProjectParameters["problem_data"]["end_time"].GetDouble() + +time = start_time +main_model_part.ProcessInfo[TIME_STEPS] = 0 + +# Solving the problem (time integration) +while(time <= end_time): + + time = time + delta_time + main_model_part.ProcessInfo[TIME_STEPS] += 1 + main_model_part.CloneTimeStep(time) + + if (parallel_type == "OpenMP") or (mpi.rank == 0): + print("") + print("STEP = ", main_model_part.ProcessInfo[TIME_STEPS]) + print("TIME = ", time) + + for process in list_of_processes: + process.ExecuteInitializeSolutionStep() + + if (output_post == True): + gid_output.ExecuteInitializeSolutionStep() + + solver.Solve() + + for process in list_of_processes: + process.ExecuteFinalizeSolutionStep() + + if (output_post == True): + gid_output.ExecuteFinalizeSolutionStep() + + for process in list_of_processes: + process.ExecuteBeforeOutputStep() + + if (output_post == True) and (gid_output.IsOutputStep()): + gid_output.PrintOutput() + + for process in list_of_processes: + process.ExecuteAfterOutputStep() + +for process in list_of_processes: + process.ExecuteFinalize() + +if (output_post == True): + gid_output.ExecuteFinalize() + +if (parallel_type == "OpenMP") or (mpi.rank == 0): + print(" ") + print("::[KSM Simulation]:: Analysis -END- ") + print(" ") diff --git a/applications/StructuralMechanicsApplication/python_scripts/python_solvers_wrapper_structural.py b/applications/StructuralMechanicsApplication/python_scripts/python_solvers_wrapper_structural.py new file mode 100644 index 000000000000..c343688ecb60 --- /dev/null +++ b/applications/StructuralMechanicsApplication/python_scripts/python_solvers_wrapper_structural.py @@ -0,0 +1,43 @@ +from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +import KratosMultiphysics + +def CreateSolver(main_model_part, custom_settings): + + if (type(main_model_part) != KratosMultiphysics.ModelPart): + raise Exception("input is expected to be provided as a Kratos ModelPart object") + + if (type(custom_settings) != KratosMultiphysics.Parameters): + raise Exception("input is expected to be provided as a Kratos Parameters object") + + parallelism = custom_settings["problem_data"]["parallel_type"].GetString() + solver_type = custom_settings["solver_settings"]["solver_type"].GetString() + + # Solvers for OpenMP parallelism + if (parallelism == "OpenMP"): + if (solver_type == "Implicit"): + solver_module_name = "structural_mechanics_implicit_dynamic_solver" + + elif (solver_type == "Static"): + solver_module_name = "structural_mechanics_static_solver" + + else: + raise Exception("the requested solver type is not in the python solvers wrapper") + + # Solvers for MPI parallelism + elif (parallelism == "MPI"): + if (solver_type == "Implicit"): + solver_module_name = "trilinos_structural_mechanics_implicit_dynamic_solver" + + elif (solver_type == "Static"): + solver_module_name = "trilinos_structural_mechanics_static_solver" + + else: + raise Exception("the requested solver type is not in the python solvers wrapper") + else: + raise Exception("parallelism is neither OpenMP nor MPI") + + solver_module = __import__(solver_module_name) + solver = solver_module.CreateSolver(main_model_part, custom_settings["solver_settings"]) + + return solver diff --git a/applications/StructuralMechanicsApplication/python_scripts/structural_mechanics_implicit_dynamic_solver.py b/applications/StructuralMechanicsApplication/python_scripts/structural_mechanics_implicit_dynamic_solver.py index 02c52f37eaff..fb1bdfc6e4f3 100644 --- a/applications/StructuralMechanicsApplication/python_scripts/structural_mechanics_implicit_dynamic_solver.py +++ b/applications/StructuralMechanicsApplication/python_scripts/structural_mechanics_implicit_dynamic_solver.py @@ -26,7 +26,7 @@ def __init__(self, main_model_part, custom_settings): # Set defaults and validate custom settings. self.dynamic_settings = KratosMultiphysics.Parameters(""" { - "damp_factor_m" :-0.01, + "damp_factor_m" :-0.3, "rayleigh_alpha": 0.0, "rayleigh_beta" : 0.0 } diff --git a/applications/StructuralMechanicsApplication/python_scripts/trilinos_structural_mechanics_implicit_dynamic_solver.py b/applications/StructuralMechanicsApplication/python_scripts/trilinos_structural_mechanics_implicit_dynamic_solver.py index 172509326fc9..f173ddd9c60c 100644 --- a/applications/StructuralMechanicsApplication/python_scripts/trilinos_structural_mechanics_implicit_dynamic_solver.py +++ b/applications/StructuralMechanicsApplication/python_scripts/trilinos_structural_mechanics_implicit_dynamic_solver.py @@ -29,7 +29,7 @@ def __init__(self, main_model_part, custom_settings): # Set defaults and validate custom settings. self.dynamic_settings = KratosMultiphysics.Parameters(""" { - "damp_factor_m" :-0.01 + "damp_factor_m" :-0.3 } """) self.validate_and_transfer_matching_settings(custom_settings, self.dynamic_settings) diff --git a/applications/StructuralMechanicsApplication/structural_mechanics_application.cpp b/applications/StructuralMechanicsApplication/structural_mechanics_application.cpp index 523321a32f8c..4e6d007989cb 100644 --- a/applications/StructuralMechanicsApplication/structural_mechanics_application.cpp +++ b/applications/StructuralMechanicsApplication/structural_mechanics_application.cpp @@ -29,7 +29,6 @@ #include "geometries/triangle_3d_6.h" #include "geometries/quadrilateral_3d_4.h" #include "geometries/quadrilateral_3d_8.h" -#include "geometries/quadrilateral_3d_8.h" #include "geometries/quadrilateral_3d_9.h" #include "geometries/prism_3d_6.h" #include "geometries/prism_3d_15.h" @@ -49,7 +48,6 @@ #include "geometries/triangle_2d_6.h" #include "geometries/quadrilateral_2d_4.h" #include "geometries/quadrilateral_2d_8.h" -#include "geometries/quadrilateral_2d_8.h" #include "geometries/quadrilateral_2d_9.h" namespace Kratos { @@ -193,7 +191,9 @@ void KratosStructuralMechanicsApplication::Register() KRATOS_REGISTER_VARIABLE(AREA_EFFECTIVE_Z) KRATOS_REGISTER_VARIABLE(INERTIA_ROT_Y) KRATOS_REGISTER_VARIABLE(INERTIA_ROT_Z) + KRATOS_REGISTER_VARIABLE(LUMPED_MASS_MATRIX) KRATOS_REGISTER_VARIABLE(LOCAL_AXES_VECTOR) + KRATOS_REGISTER_VARIABLE(LOCAL_INERTIA_VECTOR) // Shell generalized variables KRATOS_REGISTER_VARIABLE( SHELL_STRAIN ) diff --git a/applications/StructuralMechanicsApplication/structural_mechanics_application_variables.cpp b/applications/StructuralMechanicsApplication/structural_mechanics_application_variables.cpp index bfa1cd423d32..353ba26b276e 100644 --- a/applications/StructuralMechanicsApplication/structural_mechanics_application_variables.cpp +++ b/applications/StructuralMechanicsApplication/structural_mechanics_application_variables.cpp @@ -40,6 +40,7 @@ typedef array_1d Vector3; KRATOS_CREATE_VARIABLE(double, INERTIA_ROT_Z) KRATOS_CREATE_VARIABLE(Vector, LOCAL_AXES_VECTOR) KRATOS_CREATE_VARIABLE(bool, LUMPED_MASS_MATRIX) + KRATOS_CREATE_VARIABLE(Vector, LOCAL_INERTIA_VECTOR) // Shell generalized variables KRATOS_CREATE_VARIABLE( Matrix, SHELL_STRAIN ) diff --git a/applications/StructuralMechanicsApplication/structural_mechanics_application_variables.h b/applications/StructuralMechanicsApplication/structural_mechanics_application_variables.h index 94c03d014e63..27f148b1c644 100644 --- a/applications/StructuralMechanicsApplication/structural_mechanics_application_variables.h +++ b/applications/StructuralMechanicsApplication/structural_mechanics_application_variables.h @@ -54,6 +54,7 @@ namespace Kratos KRATOS_DEFINE_VARIABLE(double, INERTIA_ROT_Z) KRATOS_DEFINE_VARIABLE(Vector, LOCAL_AXES_VECTOR) KRATOS_DEFINE_VARIABLE(bool, LUMPED_MASS_MATRIX) + KRATOS_DEFINE_VARIABLE(Vector, LOCAL_INERTIA_VECTOR) // Shell generalized variables KRATOS_DEFINE_APPLICATION_VARIABLE( STRUCTURAL_MECHANICS_APPLICATION, Matrix, SHELL_STRAIN ) diff --git a/applications/StructuralMechanicsApplication/tests/test_StructuralMechanicsApplication.py b/applications/StructuralMechanicsApplication/tests/test_StructuralMechanicsApplication.py index 413f5f4a3621..d86feef00eb7 100644 --- a/applications/StructuralMechanicsApplication/tests/test_StructuralMechanicsApplication.py +++ b/applications/StructuralMechanicsApplication/tests/test_StructuralMechanicsApplication.py @@ -20,6 +20,7 @@ # Simple patch tests from test_patch_test_small_strain import TestPatchTestSmallStrain as TTestPatchTestSmallStrain from test_patch_test_large_strain import TestPatchTestLargeStrain as TTestPatchTestLargeStrain +from test_quadratic_elements import TestQuadraticElements as TTestQuadraticElements # Test loading conditions from test_loading_conditions import TestLoadingConditions as TestLoadingConditions # Basic moving mesh test @@ -111,6 +112,7 @@ def AssambleTestSuites(): smallSuite.addTest(TTestPatchTestLargeStrain('test_UL_2D_triangle')) smallSuite.addTest(TTestPatchTestLargeStrain('test_UL_2D_quadrilateral')) smallSuite.addTest(TTestPatchTestLargeStrain('test_UL_3D_hexa')) + smallSuite.addTest(TTestQuadraticElements('test_Quad8')) # Test loading conditions smallSuite.addTest(TestLoadingConditions('test_execution')) # Basic moving mesh test @@ -190,6 +192,7 @@ def AssambleTestSuites(): KratosUnittest.TestLoader().loadTestsFromTestCases([ TTestPatchTestSmallStrain, TTestPatchTestLargeStrain, + TTestQuadraticElements, TestLoadingConditions, TSimpleMeshMovingTest, TDynamicBossakTests, diff --git a/applications/StructuralMechanicsApplication/tests/test_quadratic_elements.py b/applications/StructuralMechanicsApplication/tests/test_quadratic_elements.py new file mode 100755 index 000000000000..1b8319665c61 --- /dev/null +++ b/applications/StructuralMechanicsApplication/tests/test_quadratic_elements.py @@ -0,0 +1,226 @@ +from __future__ import print_function, absolute_import, division +import KratosMultiphysics + +import KratosMultiphysics.StructuralMechanicsApplication as StructuralMechanicsApplication +import KratosMultiphysics.KratosUnittest as KratosUnittest + + +class TestQuadraticElements(KratosUnittest.TestCase): + def setUp(self): + pass + + def _add_variables(self,mp): + mp.AddNodalSolutionStepVariable(KratosMultiphysics.DISPLACEMENT) + mp.AddNodalSolutionStepVariable(KratosMultiphysics.REACTION) + mp.AddNodalSolutionStepVariable(KratosMultiphysics.VOLUME_ACCELERATION) + + + def _apply_BCs(self,mp): + for node in mp.Nodes: + node.Fix(KratosMultiphysics.DISPLACEMENT_X) + node.Fix(KratosMultiphysics.DISPLACEMENT_Y) + node.Fix(KratosMultiphysics.DISPLACEMENT_Z) + + for node in mp.Nodes: + u = KratosMultiphysics.Vector(3) + u[0] = node.X0**2 + u[1] = node.Y0**2 + u[2] = node.Z0**2 + + node.SetSolutionStepValue(KratosMultiphysics.DISPLACEMENT,0,u) + + def _apply_material_properties(self,mp,dim): + #define properties + mp.GetProperties()[0].SetValue(KratosMultiphysics.YOUNG_MODULUS,210e9) + mp.GetProperties()[0].SetValue(KratosMultiphysics.POISSON_RATIO,0.3) + mp.GetProperties()[0].SetValue(KratosMultiphysics.THICKNESS,1.0) + mp.GetProperties()[0].SetValue(KratosMultiphysics.DENSITY,1.0) + + g = [0,0,0] + mp.GetProperties()[0].SetValue(KratosMultiphysics.VOLUME_ACCELERATION,g) + + if(dim == 2): + cl = StructuralMechanicsApplication.LinearElasticPlaneStress2DLaw() + else: + cl = StructuralMechanicsApplication.LinearElastic3DLaw() + mp.GetProperties()[0].SetValue(KratosMultiphysics.CONSTITUTIVE_LAW,cl) + + def _solve(self,mp): + + #define a minimal newton raphson solver + linear_solver = KratosMultiphysics.SkylineLUFactorizationSolver() + builder_and_solver = KratosMultiphysics.ResidualBasedBlockBuilderAndSolver(linear_solver) + scheme = KratosMultiphysics.ResidualBasedIncrementalUpdateStaticScheme() + convergence_criterion = KratosMultiphysics.ResidualCriteria(1e-14,1e-20) + + max_iters = 20 + compute_reactions = True + reform_step_dofs = True + calculate_norm_dx = False + move_mesh_flag = True + strategy = KratosMultiphysics.ResidualBasedLinearStrategy(mp, + scheme, + linear_solver, + builder_and_solver, + compute_reactions, + reform_step_dofs, + calculate_norm_dx, + move_mesh_flag) + + + #strategy = KratosMultiphysics.ResidualBasedNewtonRaphsonStrategy(mp, + #scheme, + #linear_solver, + #convergence_criterion, + #builder_and_solver, + #max_iters, + #compute_reactions, + #reform_step_dofs, + #move_mesh_flag) + strategy.SetEchoLevel(0) + + strategy.Check() + strategy.Solve() + + def _check_outputs(self,mp,dim): + for elem in mp.Elements: + strains = elem.CalculateOnIntegrationPoints(KratosMultiphysics.GREEN_LAGRANGE_STRAIN_VECTOR, mp.ProcessInfo) + coords = elem.CalculateOnIntegrationPoints(KratosMultiphysics.INTEGRATION_COORDINATES, mp.ProcessInfo) + for strain,coord in zip(strains, coords): + for i in range(2): + self.assertAlmostEqual((coord[i] - 0.5 * strain[i])/coord[i], 0.0 , 1) + + def test_Quad8(self): + dim = 2 + mp = KratosMultiphysics.ModelPart("solid_part") + self._add_variables(mp) + + #KratosMultiphysics.ModelPartIO("quadratic_test/static_quadratic_quad_test").ReadModelPart(mp) + + self._apply_material_properties(mp,dim) + + # Create nodes + mp.CreateNewNode(1,0.0000000000,2.0000000000,0.0000000000) + mp.CreateNewNode(2,0.0000000000,1.7500000000,0.0000000000) + mp.CreateNewNode(3,0.2500000000,1.9375000000,0.0000000000) + mp.CreateNewNode(4,0.0000000000,1.5000000000,0.0000000000) + mp.CreateNewNode(5,0.5000000000,1.8750000000,0.0000000000) + mp.CreateNewNode(6,0.2500000000,1.4610595703,0.0000000000) + mp.CreateNewNode(7,0.5000000000,1.6485595703,0.0000000000) + mp.CreateNewNode(8,0.0000000000,1.2500000000,0.0000000000) + mp.CreateNewNode(9,0.5000000000,1.4287109375,0.0000000000) + mp.CreateNewNode(10,0.7500000000,1.8125000000,0.0000000000) + mp.CreateNewNode(11,0.5000000000,1.2132568359,0.0000000000) + mp.CreateNewNode(12,0.7500000000,1.4007568359,0.0000000000) + mp.CreateNewNode(13,0.0000000000,1.0000000000,0.0000000000) + mp.CreateNewNode(14,1.0000000000,1.7500000000,0.0000000000) + mp.CreateNewNode(15,0.2500000000,1.0000000000,0.0000000000) + mp.CreateNewNode(16,1.0000000000,1.5625000000,0.0000000000) + mp.CreateNewNode(17,0.5000000000,1.0000000000,0.0000000000) + mp.CreateNewNode(18,1.0000000000,1.3750000000,0.0000000000) + mp.CreateNewNode(19,0.0000000000,0.7500000000,0.0000000000) + mp.CreateNewNode(20,0.7500000000,1.0000000000,0.0000000000) + mp.CreateNewNode(21,1.2500000000,1.6875000000,0.0000000000) + mp.CreateNewNode(22,1.0000000000,1.1875000000,0.0000000000) + mp.CreateNewNode(23,0.5000000000,0.7867431641,0.0000000000) + mp.CreateNewNode(24,1.2500000000,1.3492431641,0.0000000000) + mp.CreateNewNode(25,1.0000000000,1.0000000000,0.0000000000) + mp.CreateNewNode(26,0.2500000000,0.5389404297,0.0000000000) + mp.CreateNewNode(27,0.0000000000,0.5000000000,0.0000000000) + mp.CreateNewNode(28,0.5000000000,0.5712890625,0.0000000000) + mp.CreateNewNode(29,1.5000000000,1.6250000000,0.0000000000) + mp.CreateNewNode(30,1.0000000000,0.8125000000,0.0000000000) + mp.CreateNewNode(31,1.5000000000,1.4764404297,0.0000000000) + mp.CreateNewNode(32,0.7500000000,0.5992431641,0.0000000000) + mp.CreateNewNode(33,1.2500000000,1.0000000000,0.0000000000) + mp.CreateNewNode(34,1.5000000000,1.3212890625,0.0000000000) + mp.CreateNewNode(35,1.0000000000,0.6250000000,0.0000000000) + mp.CreateNewNode(36,1.5000000000,1.1617431641,0.0000000000) + mp.CreateNewNode(37,0.5000000000,0.3514404297,0.0000000000) + mp.CreateNewNode(38,0.0000000000,0.2500000000,0.0000000000) + mp.CreateNewNode(39,1.5000000000,1.0000000000,0.0000000000) + mp.CreateNewNode(40,1.7500000000,1.5625000000,0.0000000000) + mp.CreateNewNode(41,1.2500000000,0.6507568359,0.0000000000) + mp.CreateNewNode(42,1.0000000000,0.4375000000,0.0000000000) + mp.CreateNewNode(43,1.7500000000,1.2889404297,0.0000000000) + mp.CreateNewNode(44,1.5000000000,0.8382568359,0.0000000000) + mp.CreateNewNode(45,0.5000000000,0.1250000000,0.0000000000) + mp.CreateNewNode(46,0.2500000000,0.0625000000,0.0000000000) + mp.CreateNewNode(47,0.7500000000,0.1875000000,0.0000000000) + mp.CreateNewNode(48,1.5000000000,0.6787109375,0.0000000000) + mp.CreateNewNode(49,0.0000000000,0.0000000000,0.0000000000) + mp.CreateNewNode(50,1.0000000000,0.2500000000,0.0000000000) + mp.CreateNewNode(51,1.7500000000,1.0000000000,0.0000000000) + mp.CreateNewNode(52,2.0000000000,1.5000000000,0.0000000000) + mp.CreateNewNode(53,2.0000000000,1.3750000000,0.0000000000) + mp.CreateNewNode(54,1.2500000000,0.3125000000,0.0000000000) + mp.CreateNewNode(55,1.5000000000,0.5235595703,0.0000000000) + mp.CreateNewNode(56,2.0000000000,1.2500000000,0.0000000000) + mp.CreateNewNode(57,1.7500000000,0.7110595703,0.0000000000) + mp.CreateNewNode(58,2.0000000000,1.1250000000,0.0000000000) + mp.CreateNewNode(59,1.5000000000,0.3750000000,0.0000000000) + mp.CreateNewNode(60,2.0000000000,1.0000000000,0.0000000000) + mp.CreateNewNode(61,2.0000000000,0.8750000000,0.0000000000) + mp.CreateNewNode(62,1.7500000000,0.4375000000,0.0000000000) + mp.CreateNewNode(63,2.0000000000,0.7500000000,0.0000000000) + mp.CreateNewNode(64,2.0000000000,0.6250000000,0.0000000000) + mp.CreateNewNode(65,2.0000000000,0.5000000000,0.0000000000) + + for node in mp.Nodes: + node.AddDof(KratosMultiphysics.DISPLACEMENT_X, KratosMultiphysics.REACTION_X) + node.AddDof(KratosMultiphysics.DISPLACEMENT_Y, KratosMultiphysics.REACTION_Y) + node.AddDof(KratosMultiphysics.DISPLACEMENT_Z, KratosMultiphysics.REACTION_Z) + + # Create Element + mp.CreateNewElement("SmallDisplacementElement2D8N",1, [45,28,27,49,37,26,38,46], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",2, [50,35,28,45,42,32,37,47], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",3, [59,48,35,50,55,41,42,54], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",4, [65,63,48,59,64,57,55,62], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",5, [28,17,13,27,23,15,19,26], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",6, [35,25,17,28,30,20,23,32], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",7, [48,39,25,35,44,33,30,41], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",8, [63,60,39,48,61,51,44,57], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",9, [17,9,4,13,11,6,8,15], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",10, [25,18,9,17,22,12,11,20], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",11, [39,34,18,25,36,24,22,33], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",12, [60,56,34,39,58,43,36,51], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",13, [9,5,1,4,7,3,2,6], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",14, [18,14,5,9,16,10,7,12], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",15, [34,29,14,18,31,21,16,24], mp.GetProperties()[0]) + mp.CreateNewElement("SmallDisplacementElement2D8N",16, [56,52,29,34,53,40,31,43], mp.GetProperties()[0]) + + self._apply_BCs(mp) + self._solve(mp) + self._check_outputs(mp,dim) + + #self.__post_process(mp) + + def __post_process(self, main_model_part): + from gid_output_process import GiDOutputProcess + self.gid_output = GiDOutputProcess(main_model_part, + "gid_output", + KratosMultiphysics.Parameters(""" + { + "result_file_configuration" : { + "gidpost_flags": { + "GiDPostMode": "GiD_PostBinary", + "WriteDeformedMeshFlag": "WriteUndeformed", + "WriteConditionsFlag": "WriteConditions", + "MultiFileFlag": "SingleFile" + }, + "nodal_results" : ["DISPLACEMENT"], + "gauss_point_results" : ["GREEN_LAGRANGE_STRAIN_TENSOR","CAUCHY_STRESS_TENSOR"] + } + } + """) + ) + + self.gid_output.ExecuteInitialize() + self.gid_output.ExecuteBeforeSolutionLoop() + self.gid_output.ExecuteInitializeSolutionStep() + self.gid_output.PrintOutput() + self.gid_output.ExecuteFinalizeSolutionStep() + self.gid_output.ExecuteFinalize() + +if __name__ == '__main__': + KratosUnittest.main() diff --git a/applications/applications_interface.py b/applications/applications_interface.py index 95ae5bd03132..ba241f5f5af2 100644 --- a/applications/applications_interface.py +++ b/applications/applications_interface.py @@ -4,7 +4,7 @@ import os.path Import_SolidMechanicsApplication = False -Import_PfemBaseApplication = False +Import_PfemApplication = False Import_PfemSolidMechanicsApplication = False Import_MachiningApplication = False Import_PfemFluidDynamicsApplication = False @@ -15,7 +15,6 @@ Import_StructuralMechanicsApplication = False Import_ConvectionDiffusionApplication = False Import_FSIApplication = False -Import_PFEMApplication = False Import_ExternalSolversApplication = False Import_ConstitutiveLawsApplication = False Import_ULFApplication = False @@ -47,7 +46,7 @@ print("Applications Available:") print("Import_SolidMechanicsApplication: False") -print("Import_PfemBaseApplication: False") +print("Import_PfemApplication: False") print("Import_PfemSolidMechanicsApplication: False") print("Import_MachiningApplication: False") print("Import_PfemFluidDynamicsApplication: False") @@ -93,7 +92,7 @@ def ImportApplications(kernel, applications_path=application_directory): # importing the applications print("Applications Available:") print("Import_SolidMechanicsApplication: " + str(Import_SolidMechanicsApplication)) - print("Import_PfemBaseApplication: " + str(Import_PfemBaseApplication)) + print("Import_PfemApplication: " + str(Import_PfemApplication)) print("Import_PfemSolidMechanicsApplication: " + str(Import_PfemSolidMechanicsApplication)) print("Import_MachiningApplication: " + str(Import_MachiningApplication)) print("Import_PfemFluidDynamicsApplication: " + str(Import_PfemFluidDynamicsApplication)) @@ -142,14 +141,14 @@ def ImportApplications(kernel, applications_path=application_directory): kernel.AddApplication(solid_mechanics_application) print("KratosSolidMechanicsApplication Succesfully imported") - if(Import_PfemBaseApplication): - print("importing KratosPfemBaseApplication ...") - sys.path.append(applications_path + '/PfemBaseApplication/python_scripts') - sys.path.append(applications_path + '/PfemBaseApplication/Linux') - from KratosPfemBaseApplication import * - pfem_base_application = KratosPfemBaseApplication() - kernel.AddApplication(pfem_base_application) - print("KratosPfemBaseApplication Succesfully imported") + if(Import_PfemApplication): + print("importing KratosPfemApplication ...") + sys.path.append(applications_path + '/PfemApplication/python_scripts') + sys.path.append(applications_path + '/PfemApplication/Linux') + from KratosPfemApplication import * + pfem_application = KratosPfemApplication() + kernel.AddApplication(pfem_application) + print("KratosPfemApplication Succesfully imported") if(Import_PfemSolidMechanicsApplication): print("importing KratosPfemSolidMechanicsApplication ...") @@ -243,15 +242,6 @@ def ImportApplications(kernel, applications_path=application_directory): kernel.AddApplication(fsi_application) print("FSIapplication Succesfully imported") - if(Import_PFEMApplication): - print("importing KratosPFEMApplication ...") - sys.path.append(applications_path + '/PFEMapplication/python_scripts') - sys.path.append(applications_path + '/PFEMapplication/Linux') - from KratosPFEMApplication import * - pfem_application = KratosPFEMApplication() - kernel.AddApplication(pfem_application) - print("KratosPFEMApplication Succesfully imported") - if(Import_ExternalSolversApplication): print("importing KratosExternalSolversApplication ...") sys.path.append(applications_path + '/ExternalSolversApplication/python_scripts') @@ -488,8 +478,8 @@ def ImportApplications(kernel, applications_path=application_directory): kernel.Initialize() if(Import_SolidMechanicsApplication): kernel.InitializeApplication(solid_mechanics_application) - if(Import_PfemBaseApplication): - kernel.InitializeApplication(pfem_base_application) + if(Import_PfemApplication): + kernel.InitializeApplication(pfem_application) if(Import_PfemSolidMechanicsApplication): kernel.InitializeApplication(pfem_solid_mechanics_application) if(Import_MachiningApplication): @@ -510,8 +500,6 @@ def ImportApplications(kernel, applications_path=application_directory): kernel.InitializeApplication(convection_diffusion_application) if(Import_FSIApplication): kernel.InitializeApplication(fsi_application) - if(Import_PFEMApplication): - kernel.InitializeApplication(pfem_application) if(Import_ExternalSolversApplication): kernel.InitializeApplication(external_solvers_application) if(Import_ConstitutiveLawsApplication): diff --git a/applications/convection_diffusion_application/CMakeLists.txt b/applications/convection_diffusion_application/CMakeLists.txt index 82571448650f..72b342c42dbf 100644 --- a/applications/convection_diffusion_application/CMakeLists.txt +++ b/applications/convection_diffusion_application/CMakeLists.txt @@ -20,6 +20,7 @@ set( KRATOS_CONVECTION_DIFFUSION_APPLICATION_SOURCES ${CMAKE_CURRENT_SOURCE_DIR}/custom_conditions/thermal_face2D.cpp ${CMAKE_CURRENT_SOURCE_DIR}/custom_conditions/thermal_face3D.cpp + ${CMAKE_CURRENT_SOURCE_DIR}/custom_conditions/flux_condition.cpp ) ############################################################### diff --git a/applications/convection_diffusion_application/convection_diffusion_application.cpp b/applications/convection_diffusion_application/convection_diffusion_application.cpp index 4e4de7bfde81..94a095b07c4c 100644 --- a/applications/convection_diffusion_application/convection_diffusion_application.cpp +++ b/applications/convection_diffusion_application/convection_diffusion_application.cpp @@ -32,9 +32,8 @@ namespace Kratos KRATOS_CREATE_VARIABLE(double, MELT_TEMPERATURE_1) KRATOS_CREATE_VARIABLE(double, MELT_TEMPERATURE_2) -KRATOS_CREATE_VARIABLE(double, ERROR) -KRATOS_CREATE_VARIABLE(double, ERROR_1) -KRATOS_CREATE_VARIABLE(double, ERROR_2) +KRATOS_CREATE_VARIABLE(double, BFECC_ERROR) +KRATOS_CREATE_VARIABLE(double, BFECC_ERROR_1) KRATOS_CREATE_VARIABLE(double, MEAN_SIZE) KRATOS_CREATE_VARIABLE(double, PROJECTED_SCALAR1) @@ -59,8 +58,10 @@ KratosConvectionDiffusionApplication::KratosConvectionDiffusionApplication(): mLaplacian3D4N(0, Element::GeometryType::Pointer(new Tetrahedra3D4 >(Element::GeometryType::PointsArrayType(4)))), mLaplacian3D8N(0, Element::GeometryType::Pointer(new Hexahedra3D8 >(Element::GeometryType::PointsArrayType(8)))), mLaplacian3D27N(0, Element::GeometryType::Pointer(new Hexahedra3D27 >(Element::GeometryType::PointsArrayType(27)))), - mThermalFace2D(0, Element::GeometryType::Pointer(new Geometry >(Element::GeometryType::PointsArrayType(2)))), - mThermalFace3D(0, Element::GeometryType::Pointer(new Triangle3D3 >(Element::GeometryType::PointsArrayType(3)))) + mThermalFace2D(0, Element::GeometryType::Pointer(new Line2D2 >(Element::GeometryType::PointsArrayType(2)))), + mThermalFace3D(0, Element::GeometryType::Pointer(new Triangle3D3 >(Element::GeometryType::PointsArrayType(3)))), + mFluxCondition2D2N(0, Element::GeometryType::Pointer(new Line2D2 >(Element::GeometryType::PointsArrayType(2)))), + mFluxCondition3D3N(0, Element::GeometryType::Pointer(new Triangle3D3 >(Element::GeometryType::PointsArrayType(3)))) {} @@ -73,9 +74,8 @@ void KratosConvectionDiffusionApplication::Register() KRATOS_REGISTER_VARIABLE(MELT_TEMPERATURE_1) KRATOS_REGISTER_VARIABLE(MELT_TEMPERATURE_2) - KRATOS_REGISTER_VARIABLE(ERROR) - KRATOS_REGISTER_VARIABLE(ERROR_1) - KRATOS_REGISTER_VARIABLE(ERROR_2) + KRATOS_REGISTER_VARIABLE(BFECC_ERROR) + KRATOS_REGISTER_VARIABLE(BFECC_ERROR_1) KRATOS_REGISTER_VARIABLE(MEAN_SIZE) KRATOS_REGISTER_VARIABLE(PROJECTED_SCALAR1) @@ -102,6 +102,8 @@ void KratosConvectionDiffusionApplication::Register() KRATOS_REGISTER_CONDITION("ThermalFace2D", mThermalFace2D); KRATOS_REGISTER_CONDITION("ThermalFace3D", mThermalFace3D); + KRATOS_REGISTER_CONDITION("FluxCondition2D2N", mFluxCondition2D2N); + KRATOS_REGISTER_CONDITION("FluxCondition3D3N", mFluxCondition3D3N); } diff --git a/applications/convection_diffusion_application/convection_diffusion_application.h b/applications/convection_diffusion_application/convection_diffusion_application.h index b4c207b92de0..4ca225bd36f6 100644 --- a/applications/convection_diffusion_application/convection_diffusion_application.h +++ b/applications/convection_diffusion_application/convection_diffusion_application.h @@ -34,6 +34,7 @@ #include "custom_elements/laplacian_element.h" #include "custom_conditions/thermal_face2D.h" #include "custom_conditions/thermal_face3D.h" +#include "custom_conditions/flux_condition.h" #include "includes/variables.h" #include "includes/condition.h" @@ -48,9 +49,8 @@ namespace Kratos // Variables definition KRATOS_DEFINE_APPLICATION_VARIABLE( CONVECTION_DIFFUSION_APPLICATION, double, MELT_TEMPERATURE_1) KRATOS_DEFINE_APPLICATION_VARIABLE( CONVECTION_DIFFUSION_APPLICATION, double, MELT_TEMPERATURE_2) -KRATOS_DEFINE_APPLICATION_VARIABLE( CONVECTION_DIFFUSION_APPLICATION, double, ERROR) -KRATOS_DEFINE_APPLICATION_VARIABLE( CONVECTION_DIFFUSION_APPLICATION, double, ERROR_1) -KRATOS_DEFINE_APPLICATION_VARIABLE( CONVECTION_DIFFUSION_APPLICATION, double, ERROR_2) +KRATOS_DEFINE_APPLICATION_VARIABLE( CONVECTION_DIFFUSION_APPLICATION, double, BFECC_ERROR) +KRATOS_DEFINE_APPLICATION_VARIABLE( CONVECTION_DIFFUSION_APPLICATION, double, BFECC_ERROR_1) KRATOS_DEFINE_APPLICATION_VARIABLE( CONVECTION_DIFFUSION_APPLICATION, double, MEAN_SIZE) KRATOS_DEFINE_APPLICATION_VARIABLE( CONVECTION_DIFFUSION_APPLICATION, double, PROJECTED_SCALAR1) @@ -224,7 +224,8 @@ class KratosConvectionDiffusionApplication : public KratosApplication const LaplacianElement mLaplacian3D27N; const ThermalFace2D mThermalFace2D; const ThermalFace3D mThermalFace3D; - + const FluxCondition<2> mFluxCondition2D2N; + const FluxCondition<3> mFluxCondition3D3N; ///@} ///@name Private Operators diff --git a/applications/convection_diffusion_application/custom_conditions/flux_condition.cpp b/applications/convection_diffusion_application/custom_conditions/flux_condition.cpp new file mode 100644 index 000000000000..88067fd1ca8e --- /dev/null +++ b/applications/convection_diffusion_application/custom_conditions/flux_condition.cpp @@ -0,0 +1,346 @@ +// | / | +// ' / __| _` | __| _ \ __| +// . \ | ( | | ( |\__ ` +// _|\_\_| \__,_|\__|\___/ ____/ +// Multi-Physics +// +// License: BSD License +// Kratos default license: kratos/license.txt +// +// Main authors: Jordi Cotela +// + +#include "flux_condition.h" +#include "includes/convection_diffusion_settings.h" + +namespace Kratos +{ + +// Public Life Cycle ////////////////////////////////////////////////////////// + +template< unsigned int TNodeNumber > +FluxCondition::FluxCondition(IndexType NewId, Geometry< Node<3> >::Pointer pGeometry): + Condition(NewId,pGeometry) +{ +} + +template< unsigned int TNodeNumber > +FluxCondition::FluxCondition( + IndexType NewId, + Geometry< Node<3> >::Pointer pGeometry, + Properties::Pointer pProperties): + Condition(NewId,pGeometry,pProperties) +{ +} + +template< unsigned int TNodeNumber > +FluxCondition::~FluxCondition() +{ +} + +// Public Operations ////////////////////////////////////////////////////////// + +template< unsigned int TNodeNumber > +Condition::Pointer FluxCondition::Create( + IndexType NewId, + NodesArrayType const& ThisNodes, + Properties::Pointer pProperties) const +{ + return Condition::Pointer(new FluxCondition(NewId, GetGeometry().Create(ThisNodes), pProperties) ); +} + +template< unsigned int TNodeNumber > +void FluxCondition::CalculateLocalSystem( + MatrixType& rLeftHandSideMatrix, + VectorType& rRightHandSideVector, + ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_TRY + + if (rLeftHandSideMatrix.size1() != TNodeNumber) + { + rLeftHandSideMatrix.resize(TNodeNumber,TNodeNumber,false); + } + noalias(rLeftHandSideMatrix) = ZeroMatrix(TNodeNumber,TNodeNumber); + + this->CalculateRightHandSide(rRightHandSideVector,rCurrentProcessInfo); + + KRATOS_CATCH("") +} + +template< unsigned int TNodeNumber > +void FluxCondition::CalculateRightHandSide( + VectorType& rRightHandSideVector, + ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_TRY + + if (rRightHandSideVector.size() != TNodeNumber) + { + rRightHandSideVector.resize(TNodeNumber,false); + } + noalias(rRightHandSideVector) = ZeroVector(TNodeNumber); + + const ProcessInfo& rProcessInfo = rCurrentProcessInfo; // to ensure that Gets are threadsafe + ConvectionDiffusionSettings& rSettings = *(rProcessInfo[CONVECTION_DIFFUSION_SETTINGS]); + + const Variable& rFluxVar = rSettings.GetSurfaceSourceVariable(); + + FluxConditionInternals::IntegrationData Data(this->GetGeometry(), rFluxVar); + + for (unsigned int g = 0; g < Data.NumGauss; g++) + { + Data.SetCurrentGaussPoint(g); + + this->AddIntegrationPointRHSContribution(rRightHandSideVector, Data); + } + + KRATOS_CATCH("") +} + +template< unsigned int TNodeNumber > +void FluxCondition::EquationIdVector( + EquationIdVectorType& rResult, + ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_TRY + + const ProcessInfo& rProcessInfo = rCurrentProcessInfo; // to ensure that Gets are threadsafe + ConvectionDiffusionSettings& rSettings = *(rProcessInfo[CONVECTION_DIFFUSION_SETTINGS]); + + const Variable& rUnknownVar = rSettings.GetUnknownVariable(); + + if (rResult.size() != TNodeNumber) + { + rResult.resize(TNodeNumber,false); + } + + Geometry< Node<3> >& rGeometry = this->GetGeometry(); + + for (unsigned int i = 0; i < TNodeNumber; i++) + { + rResult[i] = rGeometry[i].GetDof(rUnknownVar).EquationId(); + } + + KRATOS_CATCH("") +} + +template< unsigned int TNodeNumber > +void FluxCondition::GetDofList( + DofsVectorType& rConditionalDofList, + ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_TRY + + const ProcessInfo& rProcessInfo = rCurrentProcessInfo; // to ensure that Gets are threadsafe + ConvectionDiffusionSettings& rSettings = *(rProcessInfo[CONVECTION_DIFFUSION_SETTINGS]); + + const Variable& rUnknownVar = rSettings.GetUnknownVariable(); + + if (rConditionalDofList.size() != TNodeNumber) + { + rConditionalDofList.resize(TNodeNumber); + } + + Geometry< Node<3> >& rGeometry = this->GetGeometry(); + + for (unsigned int i = 0; i < TNodeNumber; i++) + { + rConditionalDofList[i] = rGeometry[i].pGetDof(rUnknownVar); + } + + KRATOS_CATCH("") +} + +template< unsigned int TNodeNumber > +GeometryData::IntegrationMethod FluxCondition::GetIntegrationMethod() +{ + return GeometryData::GI_GAUSS_2; +} + +template< unsigned int TNodeNumber > +void FluxCondition::GetValueOnIntegrationPoints( + const Variable > &rVariable, + std::vector > &rValues, + const ProcessInfo &rCurrentProcessInfo) +{ + const unsigned int NumGauss = this->GetGeometry().IntegrationPointsNumber(this->GetIntegrationMethod()); + rValues.resize(NumGauss); + if (rVariable == NORMAL) + { + this->CalculateNormal(rValues[0]); + } + else + { + /* The cast is done to avoid modification of the element's data. Data modification + * would happen if rVariable is not stored now (would initialize a pointer to &rVariable + * with associated value of 0.0). This is catastrophic if the variable referenced + * goes out of scope. + */ + const FluxCondition* const_this = static_cast< const FluxCondition* >(this); + rValues[0] = const_this->GetValue(rVariable); + } + + // Copy the values to the different gauss points + for (unsigned int g = 1; g < NumGauss; g++) + { + noalias(rValues[g]) = rValues[0]; + } +} + +template< unsigned int TNodeNumber > +void FluxCondition::GetValueOnIntegrationPoints( + const Variable& rVariable, + std::vector& rValues, + const ProcessInfo& rCurrentProcessInfo) +{ + const unsigned int NumGauss = this->GetGeometry().IntegrationPointsNumber(this->GetIntegrationMethod()); + rValues.resize(NumGauss); + const FluxCondition* const_this = static_cast< const FluxCondition* >(this); + rValues[0] = const_this->GetValue(rVariable); + for (unsigned int g = 1; g < NumGauss; g++) + { + rValues[g] = rValues[0]; + } +} + +template< unsigned int TNodeNumber > +void FluxCondition::GetValueOnIntegrationPoints( + const Variable >& rVariable, + std::vector >& rValues, + const ProcessInfo& rCurrentProcessInfo) +{ + const unsigned int NumGauss = this->GetGeometry().IntegrationPointsNumber(this->GetIntegrationMethod()); + rValues.resize(NumGauss); + const FluxCondition* const_this = static_cast< const FluxCondition* >(this); + rValues[0] = const_this->GetValue(rVariable); + for (unsigned int g = 1; g < NumGauss; g++) + { + noalias(rValues[g]) = rValues[0]; + } +} + +template< unsigned int TNodeNumber > +void FluxCondition::GetValueOnIntegrationPoints( + const Variable& rVariable, + std::vector& rValues, + const ProcessInfo& rCurrentProcessInfo) +{ + const unsigned int NumGauss = this->GetGeometry().IntegrationPointsNumber(this->GetIntegrationMethod()); + rValues.resize(NumGauss); + const FluxCondition* const_this = static_cast< const FluxCondition* >(this); + rValues[0] = const_this->GetValue(rVariable); + for (unsigned int g = 1; g < NumGauss; g++) + { + noalias(rValues[g]) = rValues[0]; + } +} + +template< unsigned int TNodeNumber > +void FluxCondition::GetValueOnIntegrationPoints( + const Variable& rVariable, + std::vector& rValues, + const ProcessInfo& rCurrentProcessInfo) +{ + const unsigned int NumGauss = this->GetGeometry().IntegrationPointsNumber(this->GetIntegrationMethod()); + rValues.resize(NumGauss); + const FluxCondition* const_this = static_cast< const FluxCondition* >(this); + rValues[0] = const_this->GetValue(rVariable); + for (unsigned int g = 1; g < NumGauss; g++) + { + noalias(rValues[g]) = rValues[0]; + } +} + +// Input and Output /////////////////////////////////////////////////////////// + +template< unsigned int TNodeNumber > +std::string FluxCondition::Info() const +{ + std::stringstream buffer; + buffer << "FluxCondition #" << Id(); + return buffer.str(); +} + +template< unsigned int TNodeNumber > +void FluxCondition::PrintInfo(std::ostream& rOStream) const +{ + rOStream << "FluxCondition #" << Id(); +} + +template< unsigned int TNodeNumber > +void FluxCondition::PrintData(std::ostream& rOStream) const +{ + rOStream << "FluxCondition #" << Id() << std::endl; + this->GetGeometry().PrintData(rOStream); +} + + +// Finite element functions /////////////////////////////////////////////////// + +template< unsigned int TNodeNumber > +void FluxCondition::AddIntegrationPointRHSContribution( + VectorType& rRightHandSideVector, + const FluxConditionInternals::IntegrationData& rData) +{ + double InterpolatedFlux = rData.GaussPointFlux(); + for (unsigned int i = 0; i < TNodeNumber; i++) + { + rRightHandSideVector[i] += rData.N(i) * InterpolatedFlux * rData.IntegrationWeight(); + } +} + + +template <> +void FluxCondition<2>::CalculateNormal(array_1d& An) +{ + Geometry >& pGeometry = this->GetGeometry(); + + An[0] = pGeometry[1].Y() - pGeometry[0].Y(); + An[1] = - (pGeometry[1].X() - pGeometry[0].X()); + An[2] = 0.00; +} + + +template <> +void FluxCondition<3>::CalculateNormal(array_1d& An ) +{ + Geometry >& pGeometry = this->GetGeometry(); + + array_1d v1,v2; + v1[0] = pGeometry[1].X() - pGeometry[0].X(); + v1[1] = pGeometry[1].Y() - pGeometry[0].Y(); + v1[2] = pGeometry[1].Z() - pGeometry[0].Z(); + + v2[0] = pGeometry[2].X() - pGeometry[0].X(); + v2[1] = pGeometry[2].Y() - pGeometry[0].Y(); + v2[2] = pGeometry[2].Z() - pGeometry[0].Z(); + + MathUtils::CrossProduct(An,v1,v2); + An *= 0.5; +} + +// Serialization ////////////////////////////////////////////////////////////// + +template< unsigned int TNodeNumber > +FluxCondition::FluxCondition(): + Condition() +{ +} + +template< unsigned int TNodeNumber > +void FluxCondition::save(Serializer& rSerializer) const +{ + KRATOS_SERIALIZE_SAVE_BASE_CLASS(rSerializer, Condition); +} + +template< unsigned int TNodeNumber > +void FluxCondition::load(Serializer& rSerializer) +{ + KRATOS_SERIALIZE_LOAD_BASE_CLASS(rSerializer, Condition); +} + +template class FluxCondition<2>; +template class FluxCondition<3>; + +} \ No newline at end of file diff --git a/applications/convection_diffusion_application/custom_conditions/flux_condition.h b/applications/convection_diffusion_application/custom_conditions/flux_condition.h new file mode 100644 index 000000000000..14b614982f8c --- /dev/null +++ b/applications/convection_diffusion_application/custom_conditions/flux_condition.h @@ -0,0 +1,272 @@ +// | / | +// ' / __| _` | __| _ \ __| +// . \ | ( | | ( |\__ ` +// _|\_\_| \__,_|\__|\___/ ____/ +// Multi-Physics +// +// License: BSD License +// Kratos default license: kratos/license.txt +// +// Main authors: Jordi Cotela +// + +#if !defined(KRATOS_FLUX_CONDITION_H_INCLUDED ) +#define KRATOS_FLUX_CONDITION_H_INCLUDED + +// System includes +#include +#include + + +// External includes + + +// Project includes +#include "includes/define.h" +#include "includes/node.h" +#include "includes/process_info.h" +#include "includes/properties.h" +#include "includes/condition.h" +#include "geometries/geometry.h" + + +namespace Kratos +{ + +///@addtogroup ConvectionDiffusionApplication +///@{ + +namespace FluxConditionInternals +{ +///@name Auxiliary data structure to hold FEM data +///@{ + +template< unsigned int TNodeNumber > +class IntegrationData +{ +public: + + IntegrationData( + Geometry< Node<3> >& rGeometry, + const Variable& rFluxVar + ): + mGaussPoint(0), + mNodalFluxes(TNodeNumber,0.0) + { + NumGauss = rGeometry.IntegrationPointsNumber(GeometryData::GI_GAUSS_2); + Vector DetJ = ZeroVector(NumGauss); + rGeometry.DeterminantOfJacobian(DetJ,GeometryData::GI_GAUSS_2); + + mShapeFunctionValues.resize(NumGauss,TNodeNumber); + mIntegrationWeights.resize(NumGauss); + + noalias(mShapeFunctionValues) = rGeometry.ShapeFunctionsValues(GeometryData::GI_GAUSS_2); + + const auto& IntegrationPoints = rGeometry.IntegrationPoints(GeometryData::GI_GAUSS_2); + + for (unsigned int g = 0; g < NumGauss; g++) + { + mIntegrationWeights[g] = DetJ[g]*IntegrationPoints[g].Weight(); + } + + for (unsigned int i = 0; i < TNodeNumber; i++) + { + mNodalFluxes[i] = rGeometry[i].FastGetSolutionStepValue(rFluxVar); + } + } + + void SetCurrentGaussPoint(unsigned int g) + { + mGaussPoint = g; + } + + double N(unsigned int i) const + { + return mShapeFunctionValues(mGaussPoint,i); + } + + double NodalFlux(unsigned int i) const + { + return mNodalFluxes[i]; + } + + double GaussPointFlux() const + { + double flux = mNodalFluxes[0]*mShapeFunctionValues(mGaussPoint,0); + for (unsigned int i = 1; i < TNodeNumber; i++) + { + flux += mNodalFluxes[i]*mShapeFunctionValues(mGaussPoint,i); + } + return flux; + } + + double IntegrationWeight() const + { + return mIntegrationWeights[mGaussPoint]; + } + + unsigned int NumGauss; + +private: + + unsigned int mGaussPoint; + + array_1d mNodalFluxes; + + Matrix mShapeFunctionValues; + + Vector mIntegrationWeights; +}; + +///@} + +} + +///@} +///@name Kratos Classes +///@{ + +/// A basic Neumann condition for convection-diffusion problems. +/** It applies a flux condition based on the nodal values of the + * variable defined as SurfaceSourceVariable by the + * CONVECTION_DIFFUSION_SETTINGS variable in the given ProcessInfo. + */ +template< unsigned int TNodeNumber > +class FluxCondition: public Condition +{ +public: + ///@name Type Definitions + ///@{ + + /// Pointer definition of FluxCondition + KRATOS_CLASS_POINTER_DEFINITION(FluxCondition); + + typedef Condition::MatrixType MatrixType; + typedef Condition::VectorType VectorType; + + ///@} + ///@name Life Cycle + ///@{ + + FluxCondition( + IndexType NewId, + Geometry< Node<3> >::Pointer pGeometry); + + FluxCondition( + IndexType NewId, + Geometry< Node<3> >::Pointer pGeometry, + Properties::Pointer pProperties); + + /// Destructor. + ~FluxCondition() override; + + ///@} + ///@name Operations + ///@{ + + Condition::Pointer Create( + IndexType NewId, + NodesArrayType const& ThisNodes, + Properties::Pointer pProperties) const override; + + void CalculateLocalSystem( + MatrixType& rLeftHandSideMatrix, + VectorType& rRightHandSideVector, + ProcessInfo& rCurrentProcessInfo) override; + + void CalculateRightHandSide( + VectorType& rRightHandSideVector, + ProcessInfo& rCurrentProcessInfo) override; + + void EquationIdVector( + EquationIdVectorType& rResult, + ProcessInfo& rCurrentProcessInfo) override; + + void GetDofList( + DofsVectorType& ConditionalDofList, + ProcessInfo& CurrentProcessInfo) override; + + GeometryData::IntegrationMethod GetIntegrationMethod() override; + + void GetValueOnIntegrationPoints(const Variable >& rVariable, + std::vector >& rValues, + const ProcessInfo& rCurrentProcessInfo) override; + + void GetValueOnIntegrationPoints(const Variable& rVariable, + std::vector& rValues, + const ProcessInfo& rCurrentProcessInfo) override; + + void GetValueOnIntegrationPoints(const Variable >& rVariable, + std::vector >& rValues, + const ProcessInfo& rCurrentProcessInfo) override; + + void GetValueOnIntegrationPoints(const Variable& rVariable, + std::vector& rValues, + const ProcessInfo& rCurrentProcessInfo) override; + + void GetValueOnIntegrationPoints(const Variable& rVariable, + std::vector& rValues, + const ProcessInfo& rCurrentProcessInfo) override; + + ///@} + ///@name Input and output + ///@{ + + /// Turn back information as a string. + std::string Info() const override; + + /// Print information about this object. + void PrintInfo(std::ostream& rOStream) const override; + + /// Print object's data. + void PrintData(std::ostream& rOStream) const override; + + ///@} + +protected: + + ///@name Protected Operations + ///@{ + + void AddIntegrationPointRHSContribution( + VectorType& rRightHandSideVector, + const FluxConditionInternals::IntegrationData& rData); + + void CalculateNormal(array_1d& An ); + + ///@} + +private: + + ///@name Serialization + ///@{ + friend class Serializer; + + // A private default constructor necessary for serialization + FluxCondition(); + + void save(Serializer& rSerializer) const override; + + void load(Serializer& rSerializer) override; + + ///@} + ///@name Un accessible methods + ///@{ + + /// Assignment operator. + FluxCondition& operator=(FluxCondition const& rOther); + + /// Copy constructor. + FluxCondition(FluxCondition const& rOther); + + ///@} + +}; // Class FluxCondition + +///@} + +///@} addtogroup block + +} // namespace Kratos. + +#endif // KRATOS_FLUX_CONDITION_H_INCLUDED defined diff --git a/applications/convection_diffusion_application/custom_conditions/thermal_face2D.cpp b/applications/convection_diffusion_application/custom_conditions/thermal_face2D.cpp index f265a6114c23..d98fbbd08128 100644 --- a/applications/convection_diffusion_application/custom_conditions/thermal_face2D.cpp +++ b/applications/convection_diffusion_application/custom_conditions/thermal_face2D.cpp @@ -180,7 +180,8 @@ void ThermalFace2D::EquationIdVector(EquationIdVectorType& rResult, ProcessInfo& { unsigned int number_of_nodes = GetGeometry().PointsNumber(); - ConvectionDiffusionSettings::Pointer my_settings = CurrentProcessInfo.GetValue(CONVECTION_DIFFUSION_SETTINGS); + const ProcessInfo &rConstProcessInfo = CurrentProcessInfo; + const ConvectionDiffusionSettings::Pointer my_settings = rConstProcessInfo.GetValue(CONVECTION_DIFFUSION_SETTINGS); const Variable& rUnknownVar = my_settings->GetUnknownVariable(); diff --git a/applications/convection_diffusion_application/custom_elements/eulerian_conv_diff.cpp b/applications/convection_diffusion_application/custom_elements/eulerian_conv_diff.cpp index 002b409508b3..c8aa1c1729f0 100644 --- a/applications/convection_diffusion_application/custom_elements/eulerian_conv_diff.cpp +++ b/applications/convection_diffusion_application/custom_elements/eulerian_conv_diff.cpp @@ -199,7 +199,7 @@ namespace Kratos //---------------------------------------------------------------------------------------- template< unsigned int TDim, unsigned int TNumNodes > - void EulerianConvectionDiffusionElement::InitializeEulerianElement(ElementVariables& rVariables, ProcessInfo& rCurrentProcessInfo) + void EulerianConvectionDiffusionElement::InitializeEulerianElement(ElementVariables& rVariables, const ProcessInfo& rCurrentProcessInfo) { KRATOS_TRY @@ -364,7 +364,8 @@ namespace Kratos template< unsigned int TDim, unsigned int TNumNodes > void EulerianConvectionDiffusionElement< TDim, TNumNodes >::CalculateRightHandSide(VectorType& rRightHandSideVector, ProcessInfo& rCurrentProcessInfo) { - KRATOS_THROW_ERROR(std::runtime_error, "CalculateRightHandSide not implemented",""); + Matrix LeftHandSide; + this->CalculateLocalSystem(LeftHandSide,rRightHandSideVector,rCurrentProcessInfo); } //---------------------------------------------------------------------------------------- diff --git a/applications/convection_diffusion_application/custom_elements/eulerian_conv_diff.h b/applications/convection_diffusion_application/custom_elements/eulerian_conv_diff.h index 17d95cf6b130..6b48005dee55 100644 --- a/applications/convection_diffusion_application/custom_elements/eulerian_conv_diff.h +++ b/applications/convection_diffusion_application/custom_elements/eulerian_conv_diff.h @@ -148,7 +148,7 @@ class KRATOS_API(CONVECTION_DIFFUSION_APPLICATION) EulerianConvectionDiffusionEl array_1d< array_1d, TNumNodes> vold; }; - void InitializeEulerianElement(ElementVariables& rVariables, ProcessInfo& rCurrentProcessInfo); + void InitializeEulerianElement(ElementVariables& rVariables, const ProcessInfo& rCurrentProcessInfo); void CalculateGeometry(boost::numeric::ublas::bounded_matrix& rDN_DX, double& rVolume); diff --git a/applications/convection_diffusion_application/custom_python/kratos_convection_diffusion_python_application.cpp b/applications/convection_diffusion_application/custom_python/kratos_convection_diffusion_python_application.cpp index 00a910fcb707..65af3a35ee26 100644 --- a/applications/convection_diffusion_application/custom_python/kratos_convection_diffusion_python_application.cpp +++ b/applications/convection_diffusion_application/custom_python/kratos_convection_diffusion_python_application.cpp @@ -108,9 +108,8 @@ BOOST_PYTHON_MODULE(KratosConvectionDiffusionApplication) KRATOS_REGISTER_IN_PYTHON_VARIABLE(DELTA_SCALAR1) KRATOS_REGISTER_IN_PYTHON_VARIABLE(THETA) - KRATOS_REGISTER_IN_PYTHON_VARIABLE(ERROR) - KRATOS_REGISTER_IN_PYTHON_VARIABLE(ERROR_1) - KRATOS_REGISTER_IN_PYTHON_VARIABLE(ERROR_2) + KRATOS_REGISTER_IN_PYTHON_VARIABLE(BFECC_ERROR) + KRATOS_REGISTER_IN_PYTHON_VARIABLE(BFECC_ERROR_1) } diff --git a/applications/convection_diffusion_application/custom_utilities/bfecc_elemental_limiter_convection.h b/applications/convection_diffusion_application/custom_utilities/bfecc_elemental_limiter_convection.h index ac69b53c53b6..fffa982c74ae 100644 --- a/applications/convection_diffusion_application/custom_utilities/bfecc_elemental_limiter_convection.h +++ b/applications/convection_diffusion_application/custom_utilities/bfecc_elemental_limiter_convection.h @@ -174,8 +174,8 @@ template class BFECCLimiterConvection } //Computing error 1 and modified solution at time N to be interpolated again - iparticle->GetValue(ERROR_1) = 0.5*iparticle->FastGetSolutionStepValue(rVar,1) - 0.5*phi_old;//computing error1 as e1 = 0.5*(rVar(n) - phi_old) - iparticle->GetValue(rVar) = iparticle->FastGetSolutionStepValue(rVar,1) + iparticle->GetValue(ERROR_1);//rVar(n)+e1 + iparticle->GetValue(BFECC_ERROR_1) = 0.5*iparticle->FastGetSolutionStepValue(rVar,1) - 0.5*phi_old;//computing error1 as e1 = 0.5*(rVar(n) - phi_old) + iparticle->GetValue(rVar) = iparticle->FastGetSolutionStepValue(rVar,1) + iparticle->GetValue(BFECC_ERROR_1);//rVar(n)+e1 } } //Backward with modified solution @@ -222,7 +222,7 @@ template class BFECCLimiterConvection double e1 = 0.00f; for(unsigned int j = 0 ; j < element_geometry.size(); j++){ - e1 += element_geometry[j].GetValue(ERROR_1); + e1 += element_geometry[j].GetValue(BFECC_ERROR_1); } e1 /= element_geometry.size(); @@ -245,7 +245,7 @@ template class BFECCLimiterConvection if(std::abs(e2) > std::abs(e1)){ for(unsigned int j = 0 ; j < element_geometry.size(); j++){ - element_geometry[j].GetValue(ERROR) = minmod(e1,element_geometry[j].GetValue(ERROR_1)); + element_geometry[j].GetValue(BFECC_ERROR) = minmod(e1,element_geometry[j].GetValue(BFECC_ERROR_1)); } } } @@ -257,7 +257,7 @@ template class BFECCLimiterConvection ModelPart::NodesContainerType::iterator iparticle = rModelPart.NodesBegin() + i; bool is_found = foundf[i]; if(is_found) { - iparticle->GetValue(rVar) = iparticle->FastGetSolutionStepValue(rVar,1) + iparticle->GetValue(ERROR); + iparticle->GetValue(rVar) = iparticle->FastGetSolutionStepValue(rVar,1) + iparticle->GetValue(BFECC_ERROR); } } //Backward with modified solution diff --git a/applications/convection_diffusion_application/custom_utilities/bfecc_limiter_convection.h b/applications/convection_diffusion_application/custom_utilities/bfecc_limiter_convection.h deleted file mode 100644 index d94b789858be..000000000000 --- a/applications/convection_diffusion_application/custom_utilities/bfecc_limiter_convection.h +++ /dev/null @@ -1,377 +0,0 @@ -/* -============================================================================== -KratosTestApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2010 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice sKRATOS_WATCH(disp);hall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== - */ - - -// -// Project Name: Kratos -// Last Modified by: $Author: rrossi $ -// Date: $Date: 2007-03-06 10:30:31 $ -// Revision: $Revision: 1.2 $ -// -// - - -#if !defined(KRATOS_BFECC_LIMITER_CONVECTION_INCLUDED ) -#define KRATOS_BFECC_LIMITER_CONVECTION_INCLUDED - -#define PRESSURE_ON_EULERIAN_MESH -#define USE_FEW_PARTICLES - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "includes/model_part.h" -#include "includes/node.h" -#include "utilities/geometry_utilities.h" -#include "geometries/tetrahedra_3d_4.h" -#include "includes/variables.h" -#include "spatial_containers/spatial_containers.h" -#include "utilities/timer.h" -#include "processes/node_erase_process.h" -#include "utilities/binbased_fast_point_locator.h" -#include "processes/find_nodal_neighbours_process.h" - - -#include -#include "utilities/timer.h" - -#ifdef _OPENMP -#include "omp.h" -#endif - - - -namespace Kratos -{ - -template class BFECCLimiterConvection -{ -public: - KRATOS_CLASS_POINTER_DEFINITION(BFECCLimiterConvection); - - BFECCLimiterConvection(typename BinBasedFastPointLocator::Pointer pSearchStructure) - : mpSearchStructure(pSearchStructure) - { - } - - ~BFECCLimiterConvection() - { - } - - //********************************************************************************************** - //********************************************************************************************** - void BFECCconvect(ModelPart& rModelPart, const Variable< double >& rVar, const Variable >& conv_var, const double substeps) - { - KRATOS_TRY - const double dt = rModelPart.GetProcessInfo()[DELTA_TIME]; - - //do movement - array_1d N; - const int max_results = 10000; - typename BinBasedFastPointLocator::ResultContainerType results(max_results); - - const int nparticles = rModelPart.Nodes().size(); - - PointerVector< Element > elem_backward( rModelPart.Nodes().size()); - std::vector< array_1d > Ns( rModelPart.Nodes().size()); - std::vector< bool > found( rModelPart.Nodes().size()); - std::vector< bool > foundf( rModelPart.Nodes().size()); - - //FIRST LOOP: estimate rVar(n+1) - #pragma omp parallel for firstprivate(results,N) - for (int i = 0; i < nparticles; i++) - { - typename BinBasedFastPointLocator::ResultIteratorType result_begin = results.begin(); - - ModelPart::NodesContainerType::iterator iparticle = rModelPart.NodesBegin() + i; - - Element::Pointer pelement; - array_1d bckPos = iparticle->Coordinates(); - const array_1d& vel = iparticle->FastGetSolutionStepValue(conv_var); - bool is_found = ConvectBySubstepping(dt,bckPos,vel, N, pelement, result_begin, max_results, -1.0, substeps); - found[i] = is_found; - - if(is_found) { - //save position backwards - elem_backward(i) = pelement; - Ns[i] = N; - - Geometry< Node < 3 > >& geom = pelement->GetGeometry(); - double phi1 = N[0] * ( geom[0].FastGetSolutionStepValue(rVar,1)); - for (unsigned int k = 1; k < geom.size(); k++) { - phi1 += N[k] * ( geom[k].FastGetSolutionStepValue(rVar,1) ); - } - - iparticle->FastGetSolutionStepValue(rVar) = phi1; - } - } - - //now obtain the value AT TIME STEP N by taking it from N+1 - #pragma omp parallel for firstprivate(results,N) - for (int i = 0; i < nparticles; i++) - { - typename BinBasedFastPointLocator::ResultIteratorType result_begin = results.begin(); - - ModelPart::NodesContainerType::iterator iparticle = rModelPart.NodesBegin() + i; - - Element::Pointer pelement; - array_1d fwdPos = iparticle->Coordinates(); - const array_1d& vel = iparticle->FastGetSolutionStepValue(conv_var,1); - bool is_found = ConvectBySubstepping(dt,fwdPos,vel, N, pelement, result_begin, max_results, 1.0, substeps); - foundf[i] = is_found; - - if(is_found) { - Geometry< Node < 3 > >& geom = pelement->GetGeometry(); - double phi_old = N[0] * ( geom[0].FastGetSolutionStepValue(rVar)); - - for (unsigned int k = 1; k < geom.size(); k++) { - phi_old += N[k] * ( geom[k].FastGetSolutionStepValue(rVar) ); - } - - //Computing error 1 and modified solution at time N to be interpolated again - iparticle->GetValue(ERROR_1) = 0.5*iparticle->FastGetSolutionStepValue(rVar,1) - 0.5*phi_old;//computing error1 as e1 = 0.5*(rVar(n) - phi_old) - iparticle->GetValue(rVar) = iparticle->FastGetSolutionStepValue(rVar,1) + iparticle->GetValue(ERROR_1);//rVar(n)+e1 - } - } - //Backward with modified solution - #pragma omp parallel for - for (int i = 0; i < nparticles; i++) - { - ModelPart::NodesContainerType::iterator iparticle = rModelPart.NodesBegin() + i; - bool is_found = found[i]; - if(is_found) { - array_1d N = Ns[i]; - Geometry< Node < 3 > >& geom = elem_backward[i].GetGeometry(); - double phi1 = N[0] * ( geom[0].GetValue(rVar)); - for (unsigned int k = 1; k < geom.size(); k++) { - phi1 += N[k] * ( geom[k].GetValue(rVar) ); - } - iparticle->FastGetSolutionStepValue(rVar) = phi1; - } -// else -// std::cout << "it should find it" << std::endl; - } - //computing error 2 with forward of phi1 - #pragma omp parallel for firstprivate(results,N) - for (int i = 0; i < nparticles; i++) - { - typename BinBasedFastPointLocator::ResultIteratorType result_begin = results.begin(); - - ModelPart::NodesContainerType::iterator iparticle = rModelPart.NodesBegin() + i; - - Element::Pointer pelement; - array_1d fwdPos = iparticle->Coordinates(); - const array_1d& vel = iparticle->FastGetSolutionStepValue(conv_var); - bool is_found = ConvectBySubstepping(dt,fwdPos,vel, N, pelement, result_begin, max_results, 1.0, substeps);//seeking forwards - found[i] = is_found; - - if(is_found) { - //Forward with - Geometry< Node < 3 > >& geom = pelement->GetGeometry(); - double phi2 = N[0] * ( geom[0].FastGetSolutionStepValue(rVar)); - for (unsigned int k = 1; k < geom.size(); k++) { - phi2 += N[k] * ( geom[k].FastGetSolutionStepValue(rVar) ); - } - //Computing error2 as e2 = rVar(n)-(phi2+e1) - iparticle->GetValue(ERROR_2) = iparticle->FastGetSolutionStepValue(rVar,1) - (phi2 + iparticle->GetValue(ERROR_1)); - } - - } - //Limiter - FindNodalNeighboursProcess adj_process(rModelPart, 10, 10); - adj_process.ClearNeighbours(); - adj_process.Execute(); - - #pragma omp parallel for - for (int i = 0; i < nparticles; i++){ - ModelPart::NodesContainerType::iterator iparticle = rModelPart.NodesBegin() + i; - iparticle->GetValue(ERROR) = iparticle->GetValue(ERROR_1); - } - - #pragma omp parallel for - for (int i = 0; i < nparticles; i++){ - ModelPart::NodesContainerType::iterator iparticle = rModelPart.NodesBegin() + i; - WeakPointerVector > & adj_iparticle = iparticle->GetValue(NEIGHBOUR_NODES); - - //double errorA = std::abs(iparticle->GetValue(ERROR_1)); - //double errorB = std::abs(iparticle->GetValue(ERROR_2)); - //double diff = errorB - errorA; - - //if( diff > std::numeric_limits::epsilon() ){ - if(std::abs(iparticle->GetValue(ERROR_2)) > std::abs(iparticle->GetValue(ERROR_1))){ - for(int j = 0 ; j < iparticle->GetValue(NEIGHBOUR_NODES).size(); j++){ - adj_iparticle[j].GetValue(ERROR) = minmod(iparticle->GetValue(ERROR_1),adj_iparticle[j].GetValue(ERROR)); - } - } - } - #pragma omp parallel for - for (int i = 0; i < nparticles; i++){ - ModelPart::NodesContainerType::iterator iparticle = rModelPart.NodesBegin() + i; - bool is_found = foundf[i]; - if(is_found) { - iparticle->GetValue(rVar) = iparticle->FastGetSolutionStepValue(rVar,1) + iparticle->GetValue(ERROR); - } - } - //Backward with modified solution - #pragma omp parallel for - for (int i = 0; i < nparticles; i++){ - ModelPart::NodesContainerType::iterator iparticle = rModelPart.NodesBegin() + i; - bool is_found = found[i]; - if(is_found) { - array_1d N = Ns[i]; - Geometry< Node < 3 > >& geom = elem_backward[i].GetGeometry(); - double phi1 = N[0] * ( geom[0].GetValue(rVar)); - for (unsigned int k = 1; k < geom.size(); k++) { - phi1 += N[k] * ( geom[k].GetValue(rVar) ); - } - iparticle->FastGetSolutionStepValue(rVar) = phi1; - } - } - - KRATOS_CATCH("") - } - - double minmod(double x, double y) { - double f; - if(x > 0.0f && y > 0.0f) - f = std::min(x,y); - else if(x < 0.0f && y < 0.0f) - f = std::max(x,y); - else - f = 0; - return f; - } - - bool ConvectBySubstepping( - const double dt, - array_1d& position, //IT WILL BE MODIFIED - const array_1d& initial_velocity, - array_1d& N, - Element::Pointer& pelement, - typename BinBasedFastPointLocator::ResultIteratorType& result_begin, - const unsigned int max_results, - const double velocity_sign, - const double subdivisions) - { - bool is_found = false; - array_1d veulerian; - const double small_dt = dt/subdivisions; - - - if(velocity_sign > 0.0) //going from the past to the future - { - noalias(position) += small_dt*initial_velocity; - unsigned int substep=0; - while(substep++ < subdivisions) - { - is_found = mpSearchStructure->FindPointOnMesh(position, N, pelement, result_begin, max_results); - - if (is_found == true) - { - Geometry< Node < 3 > >& geom = pelement->GetGeometry(); - - const double new_step_factor = static_cast(substep)/subdivisions; - const double old_step_factor = (1.0 - new_step_factor); - - noalias(veulerian) = N[0] * ( new_step_factor*geom[0].FastGetSolutionStepValue(VELOCITY) + old_step_factor*geom[0].FastGetSolutionStepValue(VELOCITY,1)); - for (unsigned int k = 1; k < geom.size(); k++) - noalias(veulerian) += N[k] * ( new_step_factor*geom[k].FastGetSolutionStepValue(VELOCITY) + old_step_factor*geom[k].FastGetSolutionStepValue(VELOCITY,1) ); - - noalias(position) += small_dt*veulerian; - - - } - else - break; - } - } - else //going from the future to the past - { - noalias(position) -= small_dt*initial_velocity; - unsigned int substep=0; - while(substep++ < subdivisions) - { - is_found = mpSearchStructure->FindPointOnMesh(position, N, pelement, result_begin, max_results); - - if (is_found == true) - { - Geometry< Node < 3 > >& geom = pelement->GetGeometry(); - - //this factors get inverted from the other case - const double old_step_factor = static_cast(substep)/subdivisions; - const double new_step_factor = (1.0 - old_step_factor); - - noalias(veulerian) = N[0] * ( new_step_factor*geom[0].FastGetSolutionStepValue(VELOCITY) + old_step_factor*geom[0].FastGetSolutionStepValue(VELOCITY,1)); - for (unsigned int k = 1; k < geom.size(); k++) - noalias(veulerian) += N[k] * ( new_step_factor*geom[k].FastGetSolutionStepValue(VELOCITY) + old_step_factor*geom[k].FastGetSolutionStepValue(VELOCITY,1) ); - - noalias(position) -= small_dt*veulerian; - - - } - else - break; - } - } - - return is_found; - - } - -private: - typename BinBasedFastPointLocator::Pointer mpSearchStructure; - - - -}; - -} // namespace Kratos. - -#endif // KRATOS_BFECC_LIMITER_CONVECTION_INCLUDED defined - - diff --git a/applications/convection_diffusion_application/python_scripts/convection_diffusion_solver.py b/applications/convection_diffusion_application/python_scripts/convection_diffusion_solver.py index d6051f23244f..a6bf997613f0 100644 --- a/applications/convection_diffusion_application/python_scripts/convection_diffusion_solver.py +++ b/applications/convection_diffusion_application/python_scripts/convection_diffusion_solver.py @@ -28,6 +28,8 @@ def AddVariables(model_part): model_part.AddNodalSolutionStepVariable(settings.GetVolumeSourceVariable()) if settings.IsDefinedSurfaceSourceVariable(): model_part.AddNodalSolutionStepVariable(settings.GetSurfaceSourceVariable()) + if settings.IsDefinedReactionVariable(): + model_part.AddNodalSolutionStepVariable(settings.GetReactionVariable()) else: raise Exception("the provided model_part does not have CONVECTION_DIFFUSION_SETTINGS defined.") @@ -44,8 +46,14 @@ def AddDofs(model_part): unknown_variable = settings.GetUnknownVariable() - for node in model_part.Nodes: - node.AddDof(unknown_variable) + if settings.IsDefinedReactionVariable(): + reaction_variable = settings.GetReactionVariable() + + for node in model_part.Nodes: + node.AddDof(unknown_variable,reaction_variable) + else: + for node in model_part.Nodes: + node.AddDof(unknown_variable) print("DOFs for the convection diffusion solver added correctly") @@ -60,6 +68,7 @@ def __init__(self, model_part, domain_size): #Variable defining the temporal scheme (0: Forward Euler, 1: Backward Euler, 0.5: Crank-Nicolson) self.theta = 0.5 + self.dynamic_tau = 0.0 if not self.model_part.ProcessInfo.Has(CONVECTION_DIFFUSION_SETTINGS): raise Exception("the provided model_part does not have CONVECTION_DIFFUSION_SETTINGS defined.") @@ -110,6 +119,7 @@ def Initialize(self): self.ValidateInput(verbose) self.model_part.ProcessInfo[THETA] = self.theta + self.model_part.ProcessInfo[DYNAMIC_TAU] = self.dynamic_tau def Solve(self): ''' Solve an iteration of the convection-diffusion problem diff --git a/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/base.post.bin b/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/base.post.bin deleted file mode 100644 index 7891cdb08c79..000000000000 Binary files a/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/base.post.bin and /dev/null differ diff --git a/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/base.time b/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/base.time deleted file mode 100644 index c976ea5f7267..000000000000 --- a/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/base.time +++ /dev/null @@ -1,407 +0,0 @@ - Start Stop Elapsed -Reading Input .......................... 97935.7s 97935.9s 0.119479s -Writing Mesh ........................... 97935.9s 97935.9s 0.0263164s -Writing Results ........................ 97936s 97936s 0.0181161s -Writing Results ........................ 97936s 97936s 0.0011969s -Writing Results ........................ 97936.1s 97936.1s 0.00281264s -Writing Results ........................ 97936.1s 97936.1s 0.00137415s -Writing Results ........................ 97936.1s 97936.1s 0.0026575s -Writing Results ........................ 97936.1s 97936.1s 0.0017235s -Writing Results ........................ 97936.1s 97936.1s 0.00253552s -Writing Results ........................ 97936.1s 97936.2s 0.00100584s -Writing Results ........................ 97936.2s 97936.2s 0.0025892s -Writing Results ........................ 97936.2s 97936.2s 0.000993995s -Writing Results ........................ 97936.2s 97936.2s 0.00268276s -Writing Results ........................ 97936.2s 97936.2s 0.0013848s -Writing Results ........................ 97936.3s 97936.3s 0.00259236s -Writing Results ........................ 97936.3s 97936.3s 0.00122927s -Writing Results ........................ 97936.3s 97936.3s 0.00258407s -Writing Results ........................ 97936.3s 97936.3s 0.00156876s -Writing Results ........................ 97936.3s 97936.3s 0.00266776s -Writing Results ........................ 97936.3s 97936.3s 0.00113571s -Writing Results ........................ 97936.4s 97936.4s 0.00286514s -Writing Results ........................ 97936.4s 97936.4s 0.00103663s -Writing Results ........................ 97936.4s 97936.4s 0.0461537s -Writing Results ........................ 97936.4s 97936.4s 0.00158179s -Writing Results ........................ 97936.5s 97936.5s 0.00278461s -Writing Results ........................ 97936.5s 97936.5s 0.00108005s -Writing Results ........................ 97936.5s 97936.5s 0.00245262s -Writing Results ........................ 97936.5s 97936.5s 0.00137415s -Writing Results ........................ 97936.5s 97936.5s 0.00268276s -Writing Results ........................ 97936.5s 97936.5s 0.00114834s -Writing Results ........................ 97936.6s 97936.6s 0.00261289s -Writing Results ........................ 97936.6s 97936.6s 0.000853462s -Writing Results ........................ 97936.6s 97936.6s 0.00330766s -Writing Results ........................ 97936.6s 97936.6s 0.0008807s -Writing Results ........................ 97936.6s 97936.6s 0.00282843s -Writing Results ........................ 97936.6s 97936.6s 0.000946625s -Writing Results ........................ 97936.7s 97936.7s 0.00266973s -Writing Results ........................ 97936.7s 97936.7s 0.00165363s -Writing Results ........................ 97936.7s 97936.7s 0.00254144s -Writing Results ........................ 97936.7s 97936.7s 0.00113532s -Writing Results ........................ 97936.7s 97936.7s 0.00239143s -Writing Results ........................ 97936.7s 97936.7s 0.00139428s -Writing Results ........................ 97936.7s 97936.7s 0.00282329s -Writing Results ........................ 97936.7s 97936.7s 0.00112269s -Writing Results ........................ 97936.8s 97936.8s 0.0028079s -Writing Results ........................ 97936.8s 97936.8s 0.00161218s -Writing Results ........................ 97936.8s 97936.8s 0.00245696s -Writing Results ........................ 97936.8s 97936.8s 0.0013927s -Writing Results ........................ 97936.8s 97936.8s 0.00223392s -Writing Results ........................ 97936.8s 97936.8s 0.00163942s -Writing Results ........................ 97936.9s 97936.9s 0.00260855s -Writing Results ........................ 97936.9s 97936.9s 0.00106703s -Writing Results ........................ 97936.9s 97936.9s 0.0033799s -Writing Results ........................ 97936.9s 97936.9s 0.00122651s -Writing Results ........................ 97936.9s 97936.9s 0.00283869s -Writing Results ........................ 97936.9s 97936.9s 0.00154389s -Writing Results ........................ 97937s 97937s 0.002755s -Writing Results ........................ 97937s 97937s 0.00113611s -Writing Results ........................ 97937s 97937s 0.00254894s -Writing Results ........................ 97937s 97937s 0.00149415s -Writing Results ........................ 97937s 97937s 0.00264684s -Writing Results ........................ 97937s 97937s 0.00157863s -Writing Results ........................ 97937.1s 97937.1s 0.00223116s -Writing Results ........................ 97937.1s 97937.1s 0.00154863s -Writing Results ........................ 97937.1s 97937.1s 0.00285132s -Writing Results ........................ 97937.1s 97937.1s 0.00154073s -Writing Results ........................ 97937.1s 97937.1s 0.00277553s -Writing Results ........................ 97937.1s 97937.1s 0.00118979s -Writing Results ........................ 97937.2s 97937.2s 0.00249959s -Writing Results ........................ 97937.2s 97937.2s 0.0016639s -Writing Results ........................ 97937.2s 97937.2s 0.00253828s -Writing Results ........................ 97937.2s 97937.2s 0.00164061s -Writing Results ........................ 97937.2s 97937.2s 0.00265631s -Writing Results ........................ 97937.2s 97937.2s 0.00100663s -Writing Results ........................ 97937.3s 97937.3s 0.00268671s -Writing Results ........................ 97937.3s 97937.3s 0.00138638s -Writing Results ........................ 97937.3s 97937.3s 0.00263894s -Writing Results ........................ 97937.3s 97937.3s 0.00168166s -Writing Results ........................ 97937.3s 97937.3s 0.00249446s -Writing Results ........................ 97937.3s 97937.3s 0.00117243s -Writing Results ........................ 97937.3s 97937.3s 0.00263105s -Writing Results ........................ 97937.3s 97937.3s 0.00165561s -Writing Results ........................ 97937.4s 97937.4s 0.00279092s -Writing Results ........................ 97937.4s 97937.4s 0.00154468s -Writing Results ........................ 97937.4s 97937.4s 0.00286672s -Writing Results ........................ 97937.4s 97937.4s 0.00110887s -Writing Results ........................ 97937.4s 97937.4s 0.00310239s -Writing Results ........................ 97937.4s 97937.4s 0.00122374s -Writing Results ........................ 97937.5s 97937.5s 0.00275855s -Writing Results ........................ 97937.5s 97937.5s 0.00161613s -Writing Results ........................ 97937.5s 97937.5s 0.00268237s -Writing Results ........................ 97937.5s 97937.5s 0.00163863s -Writing Results ........................ 97937.5s 97937.5s 0.00271158s -Writing Results ........................ 97937.5s 97937.5s 0.00161495s -Writing Results ........................ 97937.6s 97937.6s 0.00218339s -Writing Results ........................ 97937.6s 97937.6s 0.00154507s -Writing Results ........................ 97937.6s 97937.6s 0.00261921s -Writing Results ........................ 97937.6s 97937.6s 0.00149849s -Writing Results ........................ 97937.6s 97937.6s 0.00269737s -Writing Results ........................ 97937.6s 97937.6s 0.0016181s -Writing Results ........................ 97937.7s 97937.7s 0.00272855s -Writing Results ........................ 97937.7s 97937.7s 0.00168087s -Writing Results ........................ 97937.7s 97937.7s 0.00258091s -Writing Results ........................ 97937.7s 97937.7s 0.00126282s -Writing Results ........................ 97937.7s 97937.7s 0.00258012s -Writing Results ........................ 97937.7s 97937.7s 0.00163153s -Writing Results ........................ 97937.8s 97937.8s 0.00258012s -Writing Results ........................ 97937.8s 97937.8s 0.00161455s -Writing Results ........................ 97937.8s 97937.8s 0.0029662s -Writing Results ........................ 97937.8s 97937.8s 0.00169232s -Writing Results ........................ 97937.8s 97937.8s 0.00272816s -Writing Results ........................ 97937.8s 97937.8s 0.00165758s -Writing Results ........................ 97937.8s 97937.8s 0.00232353s -Writing Results ........................ 97937.8s 97937.9s 0.00170298s -Writing Results ........................ 97937.9s 97937.9s 0.00245341s -Writing Results ........................ 97937.9s 97937.9s 0.00129717s -Writing Results ........................ 97937.9s 97937.9s 0.00272855s -Writing Results ........................ 97937.9s 97937.9s 0.00135954s -Writing Results ........................ 97937.9s 97937.9s 0.00276053s -Writing Results ........................ 97937.9s 97937.9s 0.00130348s -Writing Results ........................ 97938s 97938s 0.00300488s -Writing Results ........................ 97938s 97938s 0.00111992s -Writing Results ........................ 97938s 97938s 0.00254262s -Writing Results ........................ 97938s 97938s 0.00158731s -Writing Results ........................ 97938s 97938s 0.00275698s -Writing Results ........................ 97938s 97938s 0.00172824s -Writing Results ........................ 97938.1s 97938.1s 0.00241433s -Writing Results ........................ 97938.1s 97938.1s 0.00136507s -Writing Results ........................ 97938.1s 97938.1s 0.00274s -Writing Results ........................ 97938.1s 97938.1s 0.00115545s -Writing Results ........................ 97938.1s 97938.1s 0.00320108s -Writing Results ........................ 97938.1s 97938.1s 0.00117637s -Writing Results ........................ 97938.2s 97938.2s 0.00256276s -Writing Results ........................ 97938.2s 97938.2s 0.00161889s -Writing Results ........................ 97938.2s 97938.2s 0.00260026s -Writing Results ........................ 97938.2s 97938.2s 0.00172864s -Writing Results ........................ 97938.2s 97938.2s 0.00248459s -Writing Results ........................ 97938.2s 97938.2s 0.00140928s -Writing Results ........................ 97938.2s 97938.3s 0.00274553s -Writing Results ........................ 97938.3s 97938.3s 0.00116058s -Writing Results ........................ 97938.3s 97938.3s 0.00252091s -Writing Results ........................ 97938.3s 97938.3s 0.00150126s -Writing Results ........................ 97938.3s 97938.3s 0.0025067s -Writing Results ........................ 97938.3s 97938.3s 0.00152731s -Writing Results ........................ 97938.3s 97938.3s 0.00249604s -Writing Results ........................ 97938.3s 97938.3s 0.00162639s -Writing Results ........................ 97938.4s 97938.4s 0.00249052s -Writing Results ........................ 97938.4s 97938.4s 0.00157863s -Writing Results ........................ 97938.4s 97938.4s 0.00249209s -Writing Results ........................ 97938.4s 97938.4s 0.00113255s -Writing Results ........................ 97938.4s 97938.4s 0.00254775s -Writing Results ........................ 97938.4s 97938.4s 0.00153284s -Writing Results ........................ 97938.5s 97938.5s 0.0025892s -Writing Results ........................ 97938.5s 97938.5s 0.00155494s -Writing Results ........................ 97938.5s 97938.5s 0.00249525s -Writing Results ........................ 97938.5s 97938.5s 0.00156008s -Writing Results ........................ 97938.5s 97938.5s 0.00248223s -Writing Results ........................ 97938.5s 97938.5s 0.00153915s -Writing Results ........................ 97938.5s 97938.5s 0.00212734s -Writing Results ........................ 97938.5s 97938.6s 0.00141283s -Writing Results ........................ 97938.6s 97938.6s 0.00274197s -Writing Results ........................ 97938.6s 97938.6s 0.00134612s -Writing Results ........................ 97938.6s 97938.6s 0.00269026s -Writing Results ........................ 97938.6s 97938.6s 0.00130743s -Writing Results ........................ 97938.6s 97938.6s 0.00246525s -Writing Results ........................ 97938.6s 97938.6s 0.00154429s -Writing Results ........................ 97938.7s 97938.7s 0.00277119s -Writing Results ........................ 97938.7s 97938.7s 0.00116216s -Writing Results ........................ 97938.7s 97938.7s 0.00249091s -Writing Results ........................ 97938.7s 97938.7s 0.00148547s -Writing Results ........................ 97938.7s 97938.7s 0.00258684s -Writing Results ........................ 97938.7s 97938.7s 0.00144481s -Writing Results ........................ 97938.8s 97938.8s 0.00264644s -Writing Results ........................ 97938.8s 97938.8s 0.00148547s -Writing Results ........................ 97938.8s 97938.8s 0.0028379s -Writing Results ........................ 97938.8s 97938.8s 0.00158534s -Writing Results ........................ 97938.8s 97938.8s 0.00289396s -Writing Results ........................ 97938.8s 97938.8s 0.00133862s -Writing Results ........................ 97938.9s 97938.9s 0.00247038s -Writing Results ........................ 97938.9s 97938.9s 0.00157113s -Writing Results ........................ 97938.9s 97938.9s 0.00248894s -Writing Results ........................ 97938.9s 97938.9s 0.00146139s -Writing Results ........................ 97938.9s 97938.9s 0.00268513s -Writing Results ........................ 97938.9s 97938.9s 0.00158021s -Writing Results ........................ 97939s 97939s 0.00285132s -Writing Results ........................ 97939s 97939s 0.00147007s -Writing Results ........................ 97939s 97939s 0.00272737s -Writing Results ........................ 97939s 97939s 0.00180443s -Writing Results ........................ 97939s 97939s 0.00292672s -Writing Results ........................ 97939s 97939s 0.00194023s -Writing Results ........................ 97939.1s 97939.1s 0.00283908s -Writing Results ........................ 97939.1s 97939.1s 0.00166745s -Writing Results ........................ 97939.1s 97939.1s 0.00298435s -Writing Results ........................ 97939.1s 97939.1s 0.00166034s -Writing Results ........................ 97939.1s 97939.1s 0.0029133s -Writing Results ........................ 97939.1s 97939.1s 0.00133467s -Writing Results ........................ 97939.2s 97939.2s 0.00282093s -Writing Results ........................ 97939.2s 97939.2s 0.00182298s -Writing Results ........................ 97939.2s 97939.2s 0.00274987s -Writing Results ........................ 97939.2s 97939.2s 0.00180482s -Writing Results ........................ 97939.2s 97939.2s 0.00290422s -Writing Results ........................ 97939.2s 97939.2s 0.00201365s -Writing Results ........................ 97939.3s 97939.3s 0.00287106s -Writing Results ........................ 97939.3s 97939.3s 0.00111321s -Writing Results ........................ 97939.3s 97939.3s 0.00353741s -Writing Results ........................ 97939.3s 97939.3s 0.00113611s -Writing Results ........................ 97939.3s 97939.3s 0.00299936s -Writing Results ........................ 97939.3s 97939.3s 0.00156718s -Writing Results ........................ 97939.4s 97939.4s 0.00270605s -Writing Results ........................ 97939.4s 97939.4s 0.00170377s -Writing Results ........................ 97939.4s 97939.4s 0.00285566s -Writing Results ........................ 97939.4s 97939.4s 0.00193115s -Writing Results ........................ 97939.4s 97939.4s 0.00274829s -Writing Results ........................ 97939.4s 97939.4s 0.0013023s -Writing Results ........................ 97939.5s 97939.5s 0.00289553s -Writing Results ........................ 97939.5s 97939.5s 0.0016789s -Writing Results ........................ 97939.5s 97939.5s 0.00309844s -Writing Results ........................ 97939.5s 97939.5s 0.0018064s -Writing Results ........................ 97939.5s 97939.5s 0.00287343s -Writing Results ........................ 97939.5s 97939.5s 0.00168442s -Writing Results ........................ 97939.6s 97939.6s 0.00268987s -Writing Results ........................ 97939.6s 97939.6s 0.00167534s -Writing Results ........................ 97939.6s 97939.6s 0.00301712s -Writing Results ........................ 97939.6s 97939.6s 0.00133546s -Writing Results ........................ 97939.6s 97939.6s 0.00306923s -Writing Results ........................ 97939.6s 97939.6s 0.00188338s -Writing Results ........................ 97939.7s 97939.7s 0.00279527s -Writing Results ........................ 97939.7s 97939.7s 0.00163232s -Writing Results ........................ 97939.7s 97939.7s 0.00277119s -Writing Results ........................ 97939.7s 97939.7s 0.00161495s -Writing Results ........................ 97939.7s 97939.7s 0.00262907s -Writing Results ........................ 97939.7s 97939.7s 0.00168205s -Writing Results ........................ 97939.8s 97939.8s 0.00222208s -Writing Results ........................ 97939.8s 97939.8s 0.00166192s -Writing Results ........................ 97939.8s 97939.8s 0.00273763s -Writing Results ........................ 97939.8s 97939.8s 0.00166074s -Writing Results ........................ 97939.8s 97939.8s 0.00273526s -Writing Results ........................ 97939.8s 97939.8s 0.00156915s -Writing Results ........................ 97939.9s 97939.9s 0.00261486s -Writing Results ........................ 97939.9s 97939.9s 0.00158021s -Writing Results ........................ 97939.9s 97939.9s 0.0028229s -Writing Results ........................ 97939.9s 97939.9s 0.00138362s -Writing Results ........................ 97939.9s 97939.9s 0.00251578s -Writing Results ........................ 97939.9s 97939.9s 0.00178035s -Writing Results ........................ 97940s 97940s 0.00261565s -Writing Results ........................ 97940s 97940s 0.00143217s -Writing Results ........................ 97940s 97940s 0.00283553s -Writing Results ........................ 97940s 97940s 0.00133033s -Writing Results ........................ 97940s 97940s 0.00277592s -Writing Results ........................ 97940s 97940s 0.00130783s -Writing Results ........................ 97940.1s 97940.1s 0.0028004s -Writing Results ........................ 97940.1s 97940.1s 0.00105795s -Writing Results ........................ 97940.1s 97940.1s 0.0024992s -Writing Results ........................ 97940.1s 97940.1s 0.00163389s -Writing Results ........................ 97940.1s 97940.1s 0.00248459s -Writing Results ........................ 97940.1s 97940.1s 0.00159442s -Writing Results ........................ 97940.2s 97940.2s 0.00254775s -Writing Results ........................ 97940.2s 97940.2s 0.00144639s -Writing Results ........................ 97940.2s 97940.2s 0.00271395s -Writing Results ........................ 97940.2s 97940.2s 0.00113532s -Writing Results ........................ 97940.2s 97940.2s 0.00309844s -Writing Results ........................ 97940.2s 97940.2s 0.00117598s -Writing Results ........................ 97940.3s 97940.3s 0.00251815s -Writing Results ........................ 97940.3s 97940.3s 0.00160074s -Writing Results ........................ 97940.3s 97940.3s 0.00250157s -Writing Results ........................ 97940.3s 97940.3s 0.00156284s -Writing Results ........................ 97940.3s 97940.3s 0.00255525s -Writing Results ........................ 97940.3s 97940.3s 0.00153442s -Writing Results ........................ 97940.4s 97940.4s 0.00272855s -Writing Results ........................ 97940.4s 97940.4s 0.00117914s -Writing Results ........................ 97940.4s 97940.4s 0.00264723s -Writing Results ........................ 97940.4s 97940.4s 0.00159955s -Writing Results ........................ 97940.4s 97940.4s 0.00258841s -Writing Results ........................ 97940.4s 97940.4s 0.00164692s -Writing Results ........................ 97940.5s 97940.5s 0.00265947s -Writing Results ........................ 97940.5s 97940.5s 0.00162995s -Writing Results ........................ 97940.5s 97940.5s 0.0025667s -Writing Results ........................ 97940.5s 97940.5s 0.00118032s -Writing Results ........................ 97940.5s 97940.5s 0.00304594s -Writing Results ........................ 97940.5s 97940.5s 0.0012273s -Writing Results ........................ 97940.6s 97940.6s 0.00266737s -Writing Results ........................ 97940.6s 97940.6s 0.0016714s -Writing Results ........................ 97940.6s 97940.6s 0.00262789s -Writing Results ........................ 97940.6s 97940.6s 0.00156402s -Writing Results ........................ 97940.6s 97940.6s 0.00263026s -Writing Results ........................ 97940.6s 97940.6s 0.00163784s -Writing Results ........................ 97940.7s 97940.7s 0.0026796s -Writing Results ........................ 97940.7s 97940.7s 0.00157389s -Writing Results ........................ 97940.7s 97940.7s 0.00225445s -Writing Results ........................ 97940.7s 97940.7s 0.00134888s -Writing Results ........................ 97940.7s 97940.7s 0.00273566s -Writing Results ........................ 97940.7s 97940.7s 0.0013477s -Writing Results ........................ 97940.7s 97940.8s 0.00297528s -Writing Results ........................ 97940.8s 97940.8s 0.00162324s -Writing Results ........................ 97940.8s 97940.8s 0.00268355s -Writing Results ........................ 97940.8s 97940.8s 0.00159995s -Writing Results ........................ 97940.8s 97940.8s 0.00256236s -Writing Results ........................ 97940.8s 97940.8s 0.00125296s -Writing Results ........................ 97940.8s 97940.8s 0.00259355s -Writing Results ........................ 97940.8s 97940.9s 0.00153521s -Writing Results ........................ 97940.9s 97940.9s 0.00274197s -Writing Results ........................ 97940.9s 97940.9s 0.00153718s -Writing Results ........................ 97940.9s 97940.9s 0.00279882s -Writing Results ........................ 97940.9s 97940.9s 0.00155968s -Writing Results ........................ 97940.9s 97940.9s 0.00272658s -Writing Results ........................ 97940.9s 97940.9s 0.00161139s -Writing Results ........................ 97941s 97941s 0.00267802s -Writing Results ........................ 97941s 97941s 0.00130546s -Writing Results ........................ 97941s 97941s 0.00259868s -Writing Results ........................ 97941s 97941s 0.00174679s -Writing Results ........................ 97941s 97941s 0.00258526s -Writing Results ........................ 97941s 97941s 0.00154705s -Writing Results ........................ 97941.1s 97941.1s 0.00277553s -Writing Results ........................ 97941.1s 97941.1s 0.00156284s -Writing Results ........................ 97941.1s 97941.1s 0.00270408s -Writing Results ........................ 97941.1s 97941.1s 0.00125848s -Writing Results ........................ 97941.1s 97941.1s 0.0026425s -Writing Results ........................ 97941.1s 97941.1s 0.00168205s -Writing Results ........................ 97941.2s 97941.2s 0.00253039s -Writing Results ........................ 97941.2s 97941.2s 0.00167455s -Writing Results ........................ 97941.2s 97941.2s 0.00255802s -Writing Results ........................ 97941.2s 97941.2s 0.00157271s -Writing Results ........................ 97941.2s 97941.2s 0.00286474s -Writing Results ........................ 97941.2s 97941.2s 0.00157626s -Writing Results ........................ 97941.3s 97941.3s 0.00287619s -Writing Results ........................ 97941.3s 97941.3s 0.00134178s -Writing Results ........................ 97941.3s 97941.3s 0.00268s -Writing Results ........................ 97941.3s 97941.3s 0.00171956s -Writing Results ........................ 97941.3s 97941.3s 0.00283395s -Writing Results ........................ 97941.3s 97941.3s 0.00194536s -Writing Results ........................ 97941.4s 97941.4s 0.00280592s -Writing Results ........................ 97941.4s 97941.4s 0.0014306s -Writing Results ........................ 97941.4s 97941.4s 0.00291488s -Writing Results ........................ 97941.4s 97941.4s 0.00109505s -Writing Results ........................ 97941.4s 97941.4s 0.00357254s -Writing Results ........................ 97941.4s 97941.4s 0.00117519s -Writing Results ........................ 97941.5s 97941.5s 0.00279053s -Writing Results ........................ 97941.5s 97941.5s 0.00145941s -Writing Results ........................ 97941.5s 97941.5s 0.00284619s -Writing Results ........................ 97941.5s 97941.5s 0.00177995s -Writing Results ........................ 97941.5s 97941.5s 0.00272658s -Writing Results ........................ 97941.5s 97941.5s 0.00162916s -Writing Results ........................ 97941.6s 97941.6s 0.00265394s -Writing Results ........................ 97941.6s 97941.6s 0.00118111s -Writing Results ........................ 97941.6s 97941.6s 0.00297646s -Writing Results ........................ 97941.6s 97941.6s 0.00172035s -Writing Results ........................ 97941.6s 97941.6s 0.00270842s -Writing Results ........................ 97941.6s 97941.6s 0.00162995s -Writing Results ........................ 97941.7s 97941.7s 0.00266776s -Writing Results ........................ 97941.7s 97941.7s 0.00175153s -Writing Results ........................ 97941.7s 97941.7s 0.00267289s -Writing Results ........................ 97941.7s 97941.7s 0.00178982s -Writing Results ........................ 97941.7s 97941.7s 0.00269302s -Writing Results ........................ 97941.7s 97941.7s 0.00121664s -Writing Results ........................ 97941.8s 97941.8s 0.00282408s -Writing Results ........................ 97941.8s 97941.8s 0.00158692s -Writing Results ........................ 97941.8s 97941.8s 0.00269974s -Writing Results ........................ 97941.8s 97941.8s 0.00158376s -Writing Results ........................ 97941.8s 97941.8s 0.00285724s -Writing Results ........................ 97941.8s 97941.8s 0.00182377s -Writing Results ........................ 97941.9s 97941.9s 0.00292554s -Writing Results ........................ 97941.9s 97941.9s 0.00176535s -Writing Results ........................ 97941.9s 97941.9s 0.0022134s -Writing Results ........................ 97941.9s 97941.9s 0.00159837s -Writing Results ........................ 97941.9s 97941.9s 0.00294567s -Writing Results ........................ 97941.9s 97941.9s 0.00175745s -Writing Results ........................ 97941.9s 97942s 0.00273684s -Writing Results ........................ 97942s 97942s 0.00159087s -Writing Results ........................ 97942s 97942s 0.00298949s -Writing Results ........................ 97942s 97942s 0.00160113s -Writing Results ........................ 97942s 97942s 0.00270092s -Writing Results ........................ 97942s 97942s 0.00140138s -Writing Results ........................ 97942s 97942s 0.00277434s -Writing Results ........................ 97942s 97942.1s 0.00174048s -Writing Results ........................ 97942.1s 97942.1s 0.0027475s -Writing Results ........................ 97942.1s 97942.1s 0.00157705s -Writing Results ........................ 97942.1s 97942.1s 0.00290659s -Writing Results ........................ 97942.1s 97942.1s 0.00138165s -Writing Results ........................ 97942.1s 97942.1s 0.00288093s -Writing Results ........................ 97942.1s 97942.1s 0.00138559s -Writing Results ........................ 97942.2s 97942.2s 0.00269697s -Writing Results ........................ 97942.2s 97942.2s 0.00130941s -Writing Results ........................ 97942.2s 97942.2s 0.00261605s -Writing Results ........................ 97942.2s 97942.2s 0.0016489s -Writing Results ........................ 97942.2s 97942.2s 0.00280395s -Writing Results ........................ 97942.2s 97942.2s 0.00163232s -Writing Results ........................ 97942.3s 97942.3s 0.00303883s -Writing Results ........................ 97942.3s 97942.3s 0.00162876s -Writing Results ........................ 97942.3s 97942.3s 0.00288211s -Writing Results ........................ 97942.3s 97942.3s 0.00121585s -Writing Results ........................ 97942.3s 97942.3s 0.00269855s -Writing Results ........................ 97942.3s 97942.3s 0.00180285s -Writing Results ........................ 97942.4s 97942.4s 0.00266618s -Writing Results ........................ 97942.4s 97942.4s 0.00166587s -Writing Results ........................ 97942.4s 97942.4s 0.00260539s -Writing Results ........................ 97942.4s 97942.4s 0.00166548s -Writing Results ........................ 97942.4s 97942.4s 0.00291606s -Writing Results ........................ 97942.4s 97942.4s 0.00169863s -Writing Results ........................ 97942.5s 97942.5s 0.00279013s -Writing Results ........................ 97942.5s 97942.5s 0.00122453s -Writing Results ........................ 97942.5s 97942.5s 0.00295277s -Writing Results ........................ 97942.5s 97942.5s 0.0017843s - Repeat # Total Max Min Average % -Reading Input.......................... 1 0.119479s 0.119479s 0.119479s 0.119479s 1.7292% -Writing Mesh........................... 1 0.0263164s 0.0263164s 0.0263164s 0.0263164s 0.380874% -Writing Results........................ 400 0.897893s 0.0461537s 0.000853462s 0.00224473s 12.9951% diff --git a/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/bfecc_limiter_test.post.lst b/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/bfecc_limiter_test.post.lst deleted file mode 100644 index 39402eb8485d..000000000000 --- a/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/bfecc_limiter_test.post.lst +++ /dev/null @@ -1,2 +0,0 @@ -Single -base.post.bin diff --git a/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/bfecc_test.post.lst b/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/bfecc_test.post.lst deleted file mode 100644 index 39402eb8485d..000000000000 --- a/applications/convection_diffusion_application/test_examples/bfecc_limiter_test/bfecc_test.post.lst +++ /dev/null @@ -1,2 +0,0 @@ -Single -base.post.bin diff --git a/applications/convection_diffusion_application/test_examples/bfecc_test/base.time b/applications/convection_diffusion_application/test_examples/bfecc_test/base.time deleted file mode 100644 index 0111efe68ab1..000000000000 --- a/applications/convection_diffusion_application/test_examples/bfecc_test/base.time +++ /dev/null @@ -1,407 +0,0 @@ - Start Stop Elapsed -Reading Input .......................... 1.87161e+006s 1.87161e+006s 0.120508s -Writing Mesh ........................... 1.87161e+006s 1.87161e+006s 0.0246016s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00250236s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000928073s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00234683s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000962812s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00234367s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00135717s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00234486s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000871623s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0024242s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0012802s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00254816s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00094939s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00241078s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0013477s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00195957s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00176891s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00232551s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000940311s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00269935s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000961233s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00237446s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00134691s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00251144s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00103071s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00725405s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0014231s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00224853s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143573s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00245341s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000869255s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00304239s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00124112s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00260066s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00136388s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00454484s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00465497s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00202708s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00148152s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00232393s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0013402s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00295831s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00343438s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00244907s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00134573s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00235394s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00116059s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00407863s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00111637s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00232393s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143613s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00246012s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00141441s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00243526s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00111835s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00434943s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00113453s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00347939s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0015739s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00227893s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00147994s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00226669s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0013631s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00242381s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00110453s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00236815s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00149455s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00227183s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00157982s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00284659s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0012952s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00234249s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000920573s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0047809s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000932021s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00362663s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00127428s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00242341s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00146376s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00348412s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143692s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00246605s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0010619s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00245341s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00134533s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00188931s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00103505s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00431351s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00149968s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00247907s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00146336s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00239459s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00119217s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00236973s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00140297s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00226985s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00110453s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00239499s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00138954s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0023492s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00144481s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00510026s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00118111s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00234565s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00140849s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00252526s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00149415s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0024396s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143652s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0023342s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00144205s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0067764s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00183128s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00513934s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00123401s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00257145s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00122611s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00371664s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00125809s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00265119s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000981366s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00306213s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00148981s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00228604s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0014606s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00226946s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00131415s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0025596s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00109348s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00282172s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00117282s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00222011s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0014906s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00234604s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00151034s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00232196s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00134691s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00333293s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00127467s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00310003s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00145271s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00242025s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00146889s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00226788s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00148744s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00209418s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00109742s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00522382s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00110019s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00233143s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143849s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0074313s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00145468s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00243644s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0014831s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00234091s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00147047s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00219406s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00126441s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0052929s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00123243s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00251618s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00134296s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0025371s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00141165s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00244512s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00275698s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00230104s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00135796s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00241394s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00139744s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00243683s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00141678s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00287738s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00136586s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00238236s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00118703s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00249565s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00150205s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0024542s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00138402s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00332148s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00142862s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00404349s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00111953s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00244236s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00157784s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00229433s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00150363s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00342649s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00139981s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00253592s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00138165s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00509947s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000882676s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00758959s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00192878s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00237446s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00151745s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00227459s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00158534s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00437588s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00342688s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00285014s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.000939126s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00297528s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00128493s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00233854s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143376s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00233183s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0014227s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0023638s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00104137s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00241354s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00144836s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00236341s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00141757s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00237525s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00145981s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00233459s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143573s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00355518s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00104808s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00238512s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143928s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00396178s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00144284s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00253394s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00113256s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00512158s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143849s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00284975s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00151823s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00222524s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00140928s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00383664s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00140415s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00255605s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.001491s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00244631s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00183246s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00236222s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00153363s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00452352s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00122493s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00357097s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00122611s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00258566s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00122651s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00324214s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00195799s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00284028s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00147165s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00238946s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00143376s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00471498s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00137178s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00312568s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00105637s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00253987s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00149021s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00328832s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00148863s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0023042s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00151271s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00428903s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00140968s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00260697s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00107334s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00183996s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00107374s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00229393s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00153837s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00246012s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00146415s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00482156s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00108124s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00465537s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00110887s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00288251s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00547607s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00235236s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00146652s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00232512s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0014906s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00252763s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00146731s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00207484s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00130822s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00256197s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0040277s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00535961s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00129796s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00236578s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00146573s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00242341s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00118309s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00193826s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00101295s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00589411s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00142152s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0024996s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00140968s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00243012s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00144994s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.0039981s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00150758s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00228367s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00158732s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00225722s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00137415s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00242854s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00138046s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00337714s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00082741s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00568568s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00158258s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00223393s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00151705s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00226511s -Writing Results ........................ 1.87161e+006s 1.87161e+006s 0.00138362s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00243565s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00142902s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00257184s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00111874s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00227696s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.001611s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00237525s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00151231s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00226709s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00118585s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00255447s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.000911888s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00286396s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.000948601s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.0043518s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00125612s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00229946s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00143691s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00304476s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00137375s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00437904s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00107413s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00398665s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00140652s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00710365s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.0015885s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00240407s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00145665s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00259237s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00149692s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00373993s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00107216s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00263816s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00140336s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00284896s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00142902s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00244433s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00148508s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00236854s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00145744s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00196549s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00141915s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00240723s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00151231s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00233301s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00149021s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00237407s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00142823s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.0023263s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00121664s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00229038s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00153995s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00224459s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00124467s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00268198s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00126243s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00267014s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00120875s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00203537s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00147915s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00227538s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00146928s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00195089s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.000986892s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00251855s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00133783s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00248578s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00112979s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00240367s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00146178s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00229591s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00155929s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00241275s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00148073s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00244394s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00138283s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00430127s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.0011069s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00296186s -Writing Results ........................ 1.87162e+006s 1.87162e+006s 0.00556805s - Repeat # Total Max Min Average % -Reading Input.......................... 1 0.120508s 0.120508s 0.120508s 0.120508s 2.95135% -Writing Mesh........................... 1 0.0246016s 0.0246016s 0.0246016s 0.0246016s 0.602515% -Writing Results........................ 400 0.874026s 0.00758959s 0.00082741s 0.00218506s 21.4056% diff --git a/applications/convection_diffusion_application/test_examples/square_edgebased.gid/square_edgebased.info b/applications/convection_diffusion_application/test_examples/square_edgebased.gid/square_edgebased.info deleted file mode 100755 index 90bf7fee6863..000000000000 --- a/applications/convection_diffusion_application/test_examples/square_edgebased.gid/square_edgebased.info +++ /dev/null @@ -1,59 +0,0 @@ -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: False -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosMKLSolversApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_DamApplication: False -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: True -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_ PoissonApplication: False -Import_ ElectrostaticApplication: False -Import_DamApplication: False -importing KratosIncompressibleFluidApplication ... -KratosIncompressibleFluidApplication lib loaded -KratosIncompressibleFluidApplication application created -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing KratosIncompressibleFluidApplication... -Initializing KratosIncompressibleFluidApplication...Register completed -Initializing KratosIncompressibleFluidApplication...variables succesfully registered -Initializing KratosIncompressibleFluidApplication...elements succesfully registered -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosIncompressibleFluidApplication Succesfully imported -variables for the edgebased incompressible fluid solver added correctly -square_edgebased opened for io -square_edgebased.node opened for io -square_edgebased.prop opened for io -square_edgebased.elem opened for io -square_edgebased.cond opened for io -square_edgebased.init opened for io -initializing result files - Reading Nodes : 11614 nodes read - Reading Elements : 22826 Fluid2D read -lines read : 34862 -/home/antonia/Desktop/ConvectionTest/square_edgebased.gid/script.py:80: DeprecationWarning: raising a string exception is deprecated - raise "ERROR. At least one node has to be initialized with a distance lesser than 0" -Traceback (most recent call last): - File "/home/antonia/Desktop/ConvectionTest/square_edgebased.gid/script.py", line 80, in - raise "ERROR. At least one node has to be initialized with a distance lesser than 0" -ERROR. At least one node has to be initialized with a distance lesser than 0 diff --git a/applications/convection_diffusion_application/test_examples/square_edgebased.gid/square_edgebased.png b/applications/convection_diffusion_application/test_examples/square_edgebased.gid/square_edgebased.png deleted file mode 100755 index 3a932676b646..000000000000 Binary files a/applications/convection_diffusion_application/test_examples/square_edgebased.gid/square_edgebased.png and /dev/null differ diff --git a/applications/convection_diffusion_application/test_examples/square_edgebased.gid/square_edgebased_out.mdpa b/applications/convection_diffusion_application/test_examples/square_edgebased.gid/square_edgebased_out.mdpa deleted file mode 100755 index e69de29bb2d1..000000000000 diff --git a/applications/convection_diffusion_application/test_examples/testPureConvection.gid/testPureConvection.info b/applications/convection_diffusion_application/test_examples/testPureConvection.gid/testPureConvection.info deleted file mode 100644 index 25520df46be8..000000000000 --- a/applications/convection_diffusion_application/test_examples/testPureConvection.gid/testPureConvection.info +++ /dev/null @@ -1,113 +0,0 @@ -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: False -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ConstitutiveLawsApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosMKLSolversApplication: False -Import_KratosMPISearchApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -Import_LevelSetApplication: False -Import_FluidDynamicsApplication: False -Import_KratosDEMApplication: False -Import_KratosMixedElementApplication: False -Import_ThermoMechanicalApplication: False -Applications Available: -Import_ALEApplication: False -Import_IncompressibleFluidApplication: True -Import_StructuralApplication: False -Import_ConvectionDiffusionApplication: False -Import_FSIApplication: False -Import_ExternalSolversApplication: False -Import_ConstitutiveLawsApplication: False -Import_ULFApplication: False -Import_MeshingApplication: False -Import_KratosMPISearchApplication: False -Import_KratosTrilinosApplication: False -Import_KratosMetisApplication: False -Import_PoissonApplication: False -Import_ElectrostaticApplication: False -Import_MagnetostaticApplication: False -Import_DamApplication: False -Import_TestApplication: False -Import_OpenCLApplication: False -Import_PodApplication: False -Import_LevelSetApplication:False -Import_FluidDynamicsApplication: False -Import_KratosMixedElementApplication: False -Import_KratosDEMApplication: False -Import_ThermoMechanicalApplication: False -importing KratosIncompressibleFluidApplication ... -KratosIncompressibleFluidApplication lib loaded -KratosIncompressibleFluidApplication application created -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing KratosIncompressibleFluidApplication... -Initializing KratosIncompressibleFluidApplication...Register completed -Initializing KratosIncompressibleFluidApplication...variables succesfully registered -Initializing KratosIncompressibleFluidApplication...elements succesfully registered -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -KratosIncompressibleFluidApplication Succesfully imported -Importing KratosIncompressibleFluidApplication -"kerneal entered in AddApplication" : kerneal entered in AddApplication -Initializing KratosIncompressibleFluidApplication... -Initializing KratosIncompressibleFluidApplication...Register completed -Initializing KratosIncompressibleFluidApplication...variables succesfully registered -Initializing KratosIncompressibleFluidApplication...elements succesfully registered -"Application Registered" : Application Registered -"Variables Registered" : Variables Registered -"Elements Registered" : Elements Registered -"Conditions Registered" : Conditions Registered -Initializing KratosIncompressibleFluidApplication - - - WARNING: It appears that you are still using applications_interface - to import Kratos. This will soon be OBSOLETED. - See the following message for details: - - -*** -* KratosMultiphysics was imported from the first time from -* /home/antonia/kratos/applications/incompressible_fluid_application/python_scripts/fractional_step_solver.py -* This file defines auxiliary Python tools and assumes that the -* KratosMultiphysics module and all required applications will be -* first imported from a "main" Python script. Please import -* them before importing this file. -* -* A commmon cause of this error is the use of the DEPRECATED -* applications_interface to import Kratos. To solve it please -* remove the old import system and COMPLETELY replace it with -* KratosMultiphysics modules in your main script -*** - -variables for the incompressible fluid solver added correctly -testPureConvection opened for io -testPureConvection.node opened for io -testPureConvection.prop opened for io -testPureConvection.elem opened for io -testPureConvection.cond opened for io -testPureConvection.init opened for io -initializing result files -Reading Nodes : 169 nodes read - Reading Elements : 284 Fluid2D read -lines read : 692 -dofs for the incompressible fluid solver added correctly -node 1 has zero density! -Traceback (most recent call last): - File "/home/antonia/kratos/applications/convection_diffusion_application/test_examples/testPureConvection.gid/script.py", line 97, in - raise 'node with zero density found' -TypeError: exceptions must be old-style classes or derived from BaseException, not str diff --git a/applications/convection_diffusion_application/test_examples/testPureConvection.gid/testPureConvection.png b/applications/convection_diffusion_application/test_examples/testPureConvection.gid/testPureConvection.png deleted file mode 100644 index 1df6f3e48e24..000000000000 Binary files a/applications/convection_diffusion_application/test_examples/testPureConvection.gid/testPureConvection.png and /dev/null differ diff --git a/applications/convection_diffusion_application/test_examples/testPureConvection.gid/testPureConvection_out.mdpa b/applications/convection_diffusion_application/test_examples/testPureConvection.gid/testPureConvection_out.mdpa deleted file mode 100644 index e69de29bb2d1..000000000000 diff --git a/applications/convection_diffusion_application/tests/SourceTermTest/reaction_test.csv b/applications/convection_diffusion_application/tests/SourceTermTest/reaction_test.csv new file mode 100644 index 000000000000..1f8a37d71532 --- /dev/null +++ b/applications/convection_diffusion_application/tests/SourceTermTest/reaction_test.csv @@ -0,0 +1,23 @@ +#ID, REACTION_FLUX +1, -2.4166666646192723 +2, -2.5833333312557265 +3, 0.0 +4, 0.0 +5, 0.0 +6, 0.0 +7, 0.0 +8, 0.0 +9, 0.0 +10, 0.0 +11, 0.0 +12, 0.0 +13, 0.0 +14, 0.0 +15, 0.0 +16, 0.0 +17, 0.0 +18, 0.0 +19, 0.0 +20, 0.0 +21, -2.5833333312557265 +22, -2.4166666646192727 diff --git a/applications/convection_diffusion_application/tests/ThermalCouplingTest/coupling_reference.csv b/applications/convection_diffusion_application/tests/ThermalCouplingTest/coupling_reference.csv new file mode 100644 index 000000000000..c12d1f0679c0 --- /dev/null +++ b/applications/convection_diffusion_application/tests/ThermalCouplingTest/coupling_reference.csv @@ -0,0 +1,14 @@ +#ID, TEMPERATURE +26, 295.1786153286319 +27, 295.1725374817592 +29, 295.1475940916098 +31, 295.8919769478666 +35, 296.6648475252757 +38, 297.4096130570248 +43, 298.1585409356774 +47, 298.9073755952285 +51, 299.65731268355023 +56, 300.43673954793076 +60, 301.13026419671206 +62, 301.19367427967086 +64, 301.17052354999134 diff --git a/applications/convection_diffusion_application/tests/ThermalCouplingTest/thermal_coupling_left.mdpa b/applications/convection_diffusion_application/tests/ThermalCouplingTest/thermal_coupling_left.mdpa new file mode 100644 index 000000000000..ccb0f4e0b11d --- /dev/null +++ b/applications/convection_diffusion_application/tests/ThermalCouplingTest/thermal_coupling_left.mdpa @@ -0,0 +1,76 @@ +Begin ModelPartData +// VARIABLE_NAME value +End ModelPartData + +Begin Properties 0 +End Properties + + +Begin Nodes +1 0.00000e+00 1.00000e+00 0.00000e+00 +2 0.00000e+00 8.00000e-01 0.00000e+00 +3 2.00000e-01 1.00000e+00 0.00000e+00 +4 2.00000e-01 8.00000e-01 0.00000e+00 +5 0.00000e+00 6.00000e-01 0.00000e+00 +6 3.50000e-01 6.50000e-01 0.00000e+00 +7 1.85803e-01 5.16696e-01 0.00000e+00 +8 0.00000e+00 4.00000e-01 0.00000e+00 +9 5.00000e-01 5.00000e-01 0.00000e+00 +10 3.83007e-01 3.76733e-01 0.00000e+00 +11 1.81809e-01 2.73443e-01 0.00000e+00 +12 0.00000e+00 2.00000e-01 0.00000e+00 +13 3.34641e-01 1.63923e-01 0.00000e+00 +14 6.50000e-01 3.50000e-01 0.00000e+00 +15 5.27941e-01 1.81776e-01 0.00000e+00 +16 0.00000e+00 0.00000e+00 0.00000e+00 +17 2.00000e-01 0.00000e+00 0.00000e+00 +18 4.00000e-01 0.00000e+00 0.00000e+00 +19 8.00000e-01 2.00000e-01 0.00000e+00 +20 6.00000e-01 0.00000e+00 0.00000e+00 +21 8.00000e-01 0.00000e+00 0.00000e+00 +End Nodes + +Begin Elements EulerianConvDiff2D +1 0 16 17 12 +2 0 21 19 20 +3 0 2 5 4 +4 0 2 4 1 +5 0 18 20 15 +6 0 15 20 19 +7 0 18 15 13 +8 0 13 15 10 +9 0 18 13 17 +10 0 10 15 14 +11 0 17 11 12 +12 0 3 1 4 +13 0 8 12 11 +14 0 11 17 13 +15 0 11 13 10 +16 0 8 11 7 +17 0 7 11 10 +18 0 8 7 5 +19 0 5 7 4 +20 0 19 14 15 +21 0 14 9 10 +22 0 10 6 7 +23 0 9 6 10 +24 0 6 4 7 +End Elements + + + +Begin Conditions FluxCondition2D2N +1 0 21 19 +2 0 4 3 +3 0 19 14 +4 0 14 9 +5 0 9 6 +6 0 6 4 +End Conditions + + + + + + + diff --git a/applications/convection_diffusion_application/tests/ThermalCouplingTest/thermal_coupling_right.mdpa b/applications/convection_diffusion_application/tests/ThermalCouplingTest/thermal_coupling_right.mdpa new file mode 100644 index 000000000000..09733dfde83c --- /dev/null +++ b/applications/convection_diffusion_application/tests/ThermalCouplingTest/thermal_coupling_right.mdpa @@ -0,0 +1,139 @@ +Begin ModelPartData +// VARIABLE_NAME value +End ModelPartData + +Begin Properties 0 +End Properties + + +Begin Nodes +1 1.00000e+00 0.00000e+00 0.00000e+00 +2 8.96987e-01 0.00000e+00 0.00000e+00 +3 1.00000e+00 1.21704e-01 0.00000e+00 +4 8.93890e-01 1.64322e-01 0.00000e+00 +5 8.00000e-01 0.00000e+00 0.00000e+00 +6 8.00000e-01 1.00000e-01 0.00000e+00 +7 1.00000e+00 2.60540e-01 0.00000e+00 +8 8.00000e-01 2.00000e-01 0.00000e+00 +9 8.66352e-01 3.03689e-01 0.00000e+00 +10 7.25000e-01 2.75000e-01 0.00000e+00 +11 1.00000e+00 4.21533e-01 0.00000e+00 +12 8.84468e-01 4.34468e-01 0.00000e+00 +13 7.59285e-01 3.84285e-01 0.00000e+00 +14 6.50000e-01 3.50000e-01 0.00000e+00 +15 8.14097e-01 5.22271e-01 0.00000e+00 +16 6.84285e-01 4.59285e-01 0.00000e+00 +17 5.75000e-01 4.25000e-01 0.00000e+00 +18 1.00000e+00 6.09596e-01 0.00000e+00 +19 7.19532e-01 5.65705e-01 0.00000e+00 +20 6.09285e-01 5.34285e-01 0.00000e+00 +21 8.21769e-01 6.59149e-01 0.00000e+00 +22 5.00000e-01 5.00000e-01 0.00000e+00 +23 6.67917e-01 6.51158e-01 0.00000e+00 +24 5.34285e-01 6.09285e-01 0.00000e+00 +25 1.00000e+00 8.02093e-01 0.00000e+00 +26 4.25000e-01 5.75000e-01 0.00000e+00 +27 5.78315e-01 7.13315e-01 0.00000e+00 +28 7.29069e-01 8.04069e-01 0.00000e+00 +29 4.59285e-01 6.84285e-01 0.00000e+00 +30 3.50000e-01 6.50000e-01 0.00000e+00 +31 5.32776e-01 8.08704e-01 0.00000e+00 +32 3.84285e-01 7.59285e-01 0.00000e+00 +33 1.00000e+00 1.00000e+00 0.00000e+00 +34 8.08490e-01 1.00000e+00 0.00000e+00 +35 2.75000e-01 7.25000e-01 0.00000e+00 +36 4.28724e-01 8.91271e-01 0.00000e+00 +37 6.16980e-01 1.00000e+00 0.00000e+00 +38 2.95713e-01 8.50000e-01 0.00000e+00 +39 2.00000e-01 8.00000e-01 0.00000e+00 +40 4.41317e-01 1.00000e+00 0.00000e+00 +41 2.00000e-01 9.00000e-01 0.00000e+00 +42 3.06807e-01 1.00000e+00 0.00000e+00 +43 2.00000e-01 1.00000e+00 0.00000e+00 +End Nodes + +Begin Elements EulerianConvDiff2D +1 0 5 2 6 +2 0 43 41 42 +3 0 41 39 38 +4 0 8 6 4 +5 0 2 1 3 +6 0 39 35 38 +7 0 30 26 29 +8 0 22 17 20 +9 0 14 10 13 +10 0 35 30 32 +11 0 26 22 24 +12 0 17 14 16 +13 0 10 8 9 +14 0 41 38 42 +15 0 4 6 2 +16 0 8 4 9 +17 0 29 26 24 +18 0 29 24 27 +19 0 13 10 9 +20 0 13 9 12 +21 0 24 22 20 +22 0 24 20 23 +23 0 20 17 16 +24 0 20 16 19 +25 0 32 30 29 +26 0 32 29 31 +27 0 16 14 13 +28 0 16 13 15 +29 0 35 32 38 +30 0 38 32 36 +31 0 40 42 36 +32 0 40 36 37 +33 0 27 24 23 +34 0 27 23 28 +35 0 23 20 19 +36 0 23 21 28 +37 0 31 29 27 +38 0 31 27 28 +39 0 12 9 11 +40 0 19 16 15 +41 0 19 15 21 +42 0 15 13 12 +43 0 15 12 18 +44 0 32 31 36 +45 0 36 31 37 +46 0 3 7 4 +47 0 3 4 2 +48 0 38 36 42 +49 0 4 7 9 +50 0 7 11 9 +51 0 12 11 18 +52 0 21 15 18 +53 0 21 18 25 +54 0 19 21 23 +55 0 33 34 25 +56 0 34 37 28 +57 0 21 25 28 +58 0 34 28 25 +59 0 31 28 37 +End Elements + + + +Begin Conditions FluxCondition2D2N +1 0 6 5 +2 0 43 41 +3 0 41 39 +4 0 8 6 +5 0 39 35 +6 0 30 26 +7 0 22 17 +8 0 14 10 +9 0 35 30 +10 0 26 22 +11 0 17 14 +12 0 10 8 +End Conditions + + + + + + + diff --git a/applications/convection_diffusion_application/tests/source_term_test.py b/applications/convection_diffusion_application/tests/source_term_test.py index 41481527a477..8d3aabfd3dad 100644 --- a/applications/convection_diffusion_application/tests/source_term_test.py +++ b/applications/convection_diffusion_application/tests/source_term_test.py @@ -41,9 +41,11 @@ def setUp(self): self.theta = 1.0 # Since it is steady state, use backward Euler # Note: Crank-Nicolson (theta=0.5) won't converge in a single iteration (or at all, for huge dt) + self.checked_variable = TEMPERATURE self.check_tolerance = 1e-6 self.print_output = False self.print_reference_values = False + self.calculate_reactions = False self.config = TestCaseConfiguration() @@ -105,6 +107,17 @@ def testConvectionDominated(self): self.testSourceTerm() + def testReaction(self): + self.reference_file = "reaction_test" + self.config.T_xmin = 0.0 + self.config.T_xmax = 0.0 + self.config.source = 1.0 + self.config.ux = 0.0 + self.checked_variable = REACTION_FLUX + self.calculate_reactions = True + + self.testSourceTerm() + def testSourceTerm(self): with WorkFolderScope("SourceTermTest"): @@ -132,6 +145,7 @@ def setUpModel(self): thermal_settings.SetVelocityVariable(VELOCITY) thermal_settings.SetMeshVelocityVariable(MESH_VELOCITY) #thermal_settings.SetProjectionVariable(PROJECTED_SCALAR1) + thermal_settings.SetReactionVariable(REACTION_FLUX) self.model_part.ProcessInfo.SetValue(CONVECTION_DIFFUSION_SETTINGS,thermal_settings) @@ -140,8 +154,6 @@ def setUpSolvers(self): import convection_diffusion_solver as thermal_solver thermal_solver.AddVariables(self.model_part) - thermal_solver.AddVariables(self.model_part) - model_part_io = ModelPartIO(self.input_file) model_part_io.ReadModelPart(self.model_part) @@ -150,6 +162,7 @@ def setUpSolvers(self): # thermal solver self.thermal_solver = thermal_solver.ConvectionDiffusionSolver(self.model_part,self.domain_size) + self.thermal_solver.calculate_reactions = self.calculate_reactions self.thermal_solver.theta = self.theta self.thermal_solver.Initialize() @@ -188,10 +201,10 @@ def checkResults(self): if self.print_reference_values: with open(self.reference_file+'.csv','w') as ref_file: - ref_file.write("#ID, TEMPERATURE\n") + ref_file.write("#ID, {0}\n".format(self.checked_variable.Name())) for node in self.model_part.Nodes: - temp = node.GetSolutionStepValue(TEMPERATURE,0) - ref_file.write("{0}, {1}\n".format(node.Id, temp)) + value = node.GetSolutionStepValue(self.checked_variable,0) + ref_file.write("{0}, {1}\n".format(node.Id, value)) else: with open(self.reference_file+'.csv','r') as reference_file: reference_file.readline() # skip header @@ -201,10 +214,10 @@ def checkResults(self): for node in self.model_part.Nodes: values = [ float(i) for i in line.rstrip('\n ').split(',') ] node_id = values[0] - reference_temp = values[1] + reference_value = values[1] - temperature = node.GetSolutionStepValue(TEMPERATURE) - self.assertAlmostEqual(reference_temp, temperature, delta=self.check_tolerance) + value = node.GetSolutionStepValue(self.checked_variable) + self.assertAlmostEqual(reference_value, value, delta=self.check_tolerance) line = reference_file.readline() if line != '': # If we did not reach the end of the reference file @@ -230,13 +243,17 @@ def printOutput(self): gid_io.WriteNodalResults(CONDUCTIVITY,self.model_part.Nodes,label,0) gid_io.WriteNodalResults(SPECIFIC_HEAT,self.model_part.Nodes,label,0) gid_io.WriteNodalResults(HEAT_FLUX,self.model_part.Nodes,label,0) + gid_io.WriteNodalResults(REACTION_FLUX,self.model_part.Nodes,label,0) gid_io.FinalizeResults() if __name__ == '__main__': a = SourceTermTest() a.setUp() - a.testPureDiffusion() + a.print_reference_values = False + a.print_output = True + #a.testPureDiffusion() #a.testConvectionDominated() #a.testDiffusionDominated() + a.testReaction() a.tearDown() \ No newline at end of file diff --git a/applications/convection_diffusion_application/tests/test_ConvectionDiffusionApplication.py b/applications/convection_diffusion_application/tests/test_ConvectionDiffusionApplication.py index 704a4e3b0171..da0c25fdfa14 100644 --- a/applications/convection_diffusion_application/tests/test_ConvectionDiffusionApplication.py +++ b/applications/convection_diffusion_application/tests/test_ConvectionDiffusionApplication.py @@ -7,6 +7,7 @@ # Import the tests or test_classes to create the suites from source_term_test import SourceTermTest +from thermal_coupling_test import ThermalCouplingTest def AssembleTestSuites(): ''' Populates the test suites to run. @@ -27,6 +28,8 @@ def AssembleTestSuites(): smallSuite.addTest(SourceTermTest('testPureDiffusion')) smallSuite.addTest(SourceTermTest('testDiffusionDominated')) smallSuite.addTest(SourceTermTest('testConvectionDominated')) + smallSuite.addTest(SourceTermTest('testReaction')) + smallSuite.addTest(ThermalCouplingTest('testDirichletNeumann')) # Create a test suite with the selected tests plus all small tests nightSuite = suites['nightly'] diff --git a/applications/convection_diffusion_application/tests/thermal_coupling_test.py b/applications/convection_diffusion_application/tests/thermal_coupling_test.py new file mode 100644 index 000000000000..7c53b8b83d09 --- /dev/null +++ b/applications/convection_diffusion_application/tests/thermal_coupling_test.py @@ -0,0 +1,290 @@ +from KratosMultiphysics import * +from KratosMultiphysics.ConvectionDiffusionApplication import * +try: + from KratosMultiphysics.FSIApplication import * + import NonConformant_OneSideMap as ncosm + have_fsi = True +except ImportError as e: + have_fsi = False + +import KratosMultiphysics.KratosUnittest as UnitTest + +from os import remove + +class WorkFolderScope: + def __init__(self, work_folder): + self.currentPath = os.getcwd() + self.scope = os.path.abspath(os.path.join(os.path.dirname(os.path.realpath(__file__)),work_folder)) + + def __enter__(self): + os.chdir(self.scope) + + def __exit__(self, type, value, traceback): + os.chdir(self.currentPath) + +@UnitTest.skipUnless(have_fsi,"Missing required application: FSIApplication") +class ThermalCouplingTest(UnitTest.TestCase): + + def setUp(self): + self.domain_size = 2 + self.left_input_file = "thermal_coupling_left" + self.right_input_file = "thermal_coupling_right" + self.reference_file = "coupling_reference" + + self.dt = 0.01 #1e10 # This is steady state test + self.nsteps = 30 + self.theta = 1.0 # Note: I don't think the face condition supports Crank-Nicolson (JC) + # Note: Crank-Nicolson (theta=0.5) won't converge in a single iteration (or at all, for huge dt) + self.num_coupling_iterations = 10 + self.temperature_relaxation_factor = 0.7 + self.coupling_relative_tolerance = 1e-5 + + self.rho = 1.0 + self.c = 1.0 + self.k = 1.0 + + self.ux = 0.0 + self.source = 0.0 + + self.check_tolerance = 1e-6 + self.print_output = False + self.print_reference_values = False + self.calculate_reactions = True + + def tearDown(self): + self.deleteOutFile(self.left_input_file+'.time') + self.deleteOutFile(self.right_input_file+'.time') + + def deleteOutFile(self,filename): + with WorkFolderScope("ThermalCouplingTest"): + try: + remove(filename) + except FileNotFoundError as e: + pass + + def testDirichletNeumann(self): + + with WorkFolderScope("ThermalCouplingTest"): + self.setUpModel() + self.setUpSolvers() + self.setUpMapper() + + self.setUpOuterBoundaryCondition(self.left_model_part,0.0,303.15) + self.setUpOuterBoundaryCondition(self.right_model_part,1.0,293.15) + self.setUpDirichletCouplingBoundary(self.right_model_part) + #self.setUpDirichletCouplingBoundary(self.left_model_part) + + if self.print_output: + num_left_nodes = len(self.left_model_part.Nodes) + for node in self.right_model_part.Nodes: + node.Id = node.Id + num_left_nodes + self.InitializeOutput() + + self.runTest() + + self.checkResults(self.mapper.str_interface.Nodes,TEMPERATURE) + if self.print_output: + self.FinalizeOutput() + + + def setUpModel(self): + + self.left_model_part = ModelPart("LeftSide") + self.right_model_part = ModelPart("RightSide") + + thermal_settings = ConvectionDiffusionSettings() + thermal_settings.SetUnknownVariable(TEMPERATURE) + thermal_settings.SetDensityVariable(DENSITY) + thermal_settings.SetSpecificHeatVariable(SPECIFIC_HEAT) + thermal_settings.SetDiffusionVariable(CONDUCTIVITY) + thermal_settings.SetVolumeSourceVariable(HEAT_FLUX) + thermal_settings.SetSurfaceSourceVariable(FACE_HEAT_FLUX) + thermal_settings.SetVelocityVariable(VELOCITY) + thermal_settings.SetMeshVelocityVariable(MESH_VELOCITY) + #thermal_settings.SetProjectionVariable(PROJECTED_SCALAR1) + thermal_settings.SetReactionVariable(REACTION_FLUX) + + self.left_model_part.ProcessInfo.SetValue(CONVECTION_DIFFUSION_SETTINGS,thermal_settings) + self.right_model_part.ProcessInfo.SetValue(CONVECTION_DIFFUSION_SETTINGS,thermal_settings) + + def setUpSolvers(self): + + import convection_diffusion_solver as thermal_solver + thermal_solver.AddVariables(self.left_model_part) + thermal_solver.AddVariables(self.right_model_part) + # Also add mapper variables + ncosm.AddVariables(self.left_model_part,self.right_model_part) + # auxiliary container for reaction->distributed flux conversion + self.right_model_part.AddNodalSolutionStepVariable(NODAL_PAUX) + # Temporary container for un-relaxed temperature + self.left_model_part.AddNodalSolutionStepVariable(NODAL_PAUX) + + model_part_io_left = ModelPartIO(self.left_input_file) + model_part_io_left.ReadModelPart(self.left_model_part) + + model_part_io_right = ModelPartIO(self.right_input_file) + model_part_io_right.ReadModelPart(self.right_model_part) + + self.left_model_part.SetBufferSize(2) + self.right_model_part.SetBufferSize(2) + thermal_solver.AddDofs(self.left_model_part) + thermal_solver.AddDofs(self.right_model_part) + + self.left_solver = thermal_solver.ConvectionDiffusionSolver(self.left_model_part,self.domain_size) + self.left_solver.calculate_reactions = self.calculate_reactions + self.left_solver.theta = self.theta + self.left_solver.echo_level = 0 + self.left_solver.Initialize() + + self.right_solver = thermal_solver.ConvectionDiffusionSolver(self.right_model_part,self.domain_size) + self.right_solver.calculate_reactions = self.calculate_reactions + self.right_solver.theta = self.theta + self.right_solver.echo_level = 0 + self.right_solver.Initialize() + + def setUpOuterBoundaryCondition(self,model_part,boundary_x,boundary_value): + + velocity = Array3() + velocity[0] = self.ux + velocity[1] = 0.0 + velocity[2] = 0.0 + + ## Set initial and boundary conditions + for node in model_part.Nodes: + node.SetSolutionStepValue(DENSITY,self.rho) + node.SetSolutionStepValue(CONDUCTIVITY,self.k) + node.SetSolutionStepValue(SPECIFIC_HEAT,self.c) + node.SetSolutionStepValue(HEAT_FLUX,self.source) + node.SetSolutionStepValue(VELOCITY,velocity) + node.SetSolutionStepValue(TEMPERATURE,boundary_value) + + if node.X == boundary_x: + node.Fix(TEMPERATURE) + + def setUpDirichletCouplingBoundary(self,model_part): + for cond in model_part.Conditions: + for node in cond.GetNodes(): + node.Fix(TEMPERATURE) + + def setUpMapper(self): + for cond in self.left_model_part.Conditions: + for node in cond.GetNodes(): + node.Set(INTERFACE,True) + + for cond in self.right_model_part.Conditions: + for node in cond.GetNodes(): + node.Set(INTERFACE,True) + + self.mapper = ncosm.NonConformant_OneSideMap(self.left_model_part,self.right_model_part, + search_radius_factor=2.0, it_max=50, tol=1e-5) + + def runTest(self): + time = 0.0 + + for step in range(self.nsteps): + time = time+self.dt + self.left_model_part.CloneTimeStep(time) + self.right_model_part.CloneTimeStep(time) + + iter = 0 + while iter < self.num_coupling_iterations: + + # Solve Dirichlet side -> Get reactions + self.right_solver.Solve() + + # Map reactions + VariableRedistributionUtility.DistributePointValues( + self.mapper.str_interface, REACTION_FLUX, NODAL_PAUX, 1e-5, 50) + self.mapper.StructureToFluid_ScalarMap(NODAL_PAUX,FACE_HEAT_FLUX,False) + + # Solve Neumann side + self.left_solver.Solve() + + # Get updated temperature + self.mapper.FluidToStructure_ScalarMap(TEMPERATURE,NODAL_PAUX,True) + temperature_difference = 0.0 + for node in self.mapper.str_interface.Nodes: + old_temperature = node.GetSolutionStepValue(TEMPERATURE) + new_temperature = node.GetSolutionStepValue(NODAL_PAUX) + interpolated_temperature = (1.0-self.temperature_relaxation_factor)*old_temperature + self.temperature_relaxation_factor*new_temperature + temperature_difference += (old_temperature-new_temperature)**2 + node.SetSolutionStepValue(TEMPERATURE, interpolated_temperature ) + + iter += 1 + if (temperature_difference**0.5)/len(self.mapper.str_interface.Nodes) <= self.coupling_relative_tolerance: + #print("Convergence after {0} coupling iterations".format(iter)) + break + + if self.print_output: + self.PrintOutput() + + + def checkResults(self,nodes,checked_variable): + + if self.print_reference_values: + with open(self.reference_file+'.csv','w') as ref_file: + ref_file.write("#ID, {0}\n".format(checked_variable.Name())) + for node in nodes: + value = node.GetSolutionStepValue(checked_variable,0) + ref_file.write("{0}, {1}\n".format(node.Id, value)) + else: + with open(self.reference_file+'.csv','r') as reference_file: + reference_file.readline() # skip header + line = reference_file.readline() + + for node in nodes: + values = [ float(i) for i in line.rstrip('\n ').split(',') ] + node_id = values[0] + reference_value = values[1] + + value = node.GetSolutionStepValue(checked_variable) + self.assertAlmostEqual(reference_value, value, delta=self.check_tolerance) + + line = reference_file.readline() + if line != '': # If we did not reach the end of the reference file + self.fail("The number of nodes in the mdpa is smaller than the number of nodes in the output file") + + + def InitializeOutput(self): + gid_mode = GiDPostMode.GiD_PostBinary + multifile = MultiFileFlag.SingleFile + deformed_mesh_flag = WriteDeformedMeshFlag.WriteUndeformed + write_conditions = WriteConditionsFlag.WriteElementsOnly + self.left_gid_io = GidIO(self.left_input_file,gid_mode,multifile,deformed_mesh_flag, write_conditions) + self.right_gid_io = GidIO(self.right_input_file,gid_mode,multifile,deformed_mesh_flag, write_conditions) + + mesh_name = 0.0 + self.left_gid_io.InitializeMesh( mesh_name) + self.left_gid_io.WriteMesh( self.left_model_part.GetMesh() ) + self.left_gid_io.FinalizeMesh() + self.left_gid_io.InitializeResults(mesh_name,(self.left_model_part).GetMesh()) + + + self.right_gid_io.InitializeMesh( mesh_name) + self.right_gid_io.WriteMesh( self.right_model_part.GetMesh() ) + self.right_gid_io.FinalizeMesh() + self.right_gid_io.InitializeResults(mesh_name,(self.right_model_part).GetMesh()) + + def FinalizeOutput(self): + self.left_gid_io.FinalizeResults() + self.right_gid_io.FinalizeResults() + + def PrintOutput(self): + for model_part,gid_io in [[self.left_model_part,self.left_gid_io],[self.right_model_part,self.right_gid_io]]: + label = model_part.ProcessInfo[TIME] + gid_io.WriteNodalResults(VELOCITY,model_part.Nodes,label,0) + gid_io.WriteNodalResults(TEMPERATURE,model_part.Nodes,label,0) + gid_io.WriteNodalResults(DENSITY,model_part.Nodes,label,0) + gid_io.WriteNodalResults(CONDUCTIVITY,model_part.Nodes,label,0) + gid_io.WriteNodalResults(SPECIFIC_HEAT,model_part.Nodes,label,0) + gid_io.WriteNodalResults(HEAT_FLUX,model_part.Nodes,label,0) + gid_io.WriteNodalResults(FACE_HEAT_FLUX,model_part.Nodes,label,0) + gid_io.WriteNodalResults(REACTION_FLUX,model_part.Nodes,label,0) + +if __name__ == '__main__': + test = ThermalCouplingTest() + test.setUp() + #test.print_reference_values = True + test.print_output = True + test.testDirichletNeumann() + test.tearDown() \ No newline at end of file diff --git a/applications/empire_application/README.md b/applications/empire_application/README.md index bb829f4a2cbc..c71341797ba4 100644 --- a/applications/empire_application/README.md +++ b/applications/empire_application/README.md @@ -6,3 +6,4 @@ _EMPIRE_ is a research tool for co-simulation in the context of field and signal Got to [Website_EMPIRE](http://empire.st.bv.tum.de) and follow the [instructions](http://empire-multiphysics.com/projects/empire/wiki/HowTos) on how to download and install it. +_EMPIRE_ requires an MPI installation (e.g. OpenMPI), but Kratos does not have to be compiled with MPI \ No newline at end of file diff --git a/applications/empire_application/python_scripts/empire_mapper.py b/applications/empire_application/python_scripts/empire_mapper.py index 43d41e0477fd..e16876fd0496 100644 --- a/applications/empire_application/python_scripts/empire_mapper.py +++ b/applications/empire_application/python_scripts/empire_mapper.py @@ -12,8 +12,10 @@ # TODO Aditya does the first case work all the time? Also should we change the two cases? try: # OpenMPI libMapper = ctp.CDLL(os.environ['EMPIRE_MAPPER_LIBSO_ON_MACHINE'], ctp.RTLD_GLOBAL) -except: # Intel MPI & OpenMPI with "–disable-dlopen" + print("::EMPIRE:: Using standard OpenMPI") +except: # Intel MPI or OpenMPI compiled with "–disable-dlopen" option libMapper = ctp.cdll.LoadLibrary(os.environ['EMPIRE_MAPPER_LIBSO_ON_MACHINE']) + print("::EMPIRE:: Using Intel MPI or OpenMPI compiled with \"–disable-dlopen\" option") ## Wrapper class for the mapper # Consturctor will have two model parts as arguments, type of mapper and then options to the mapper. diff --git a/applications/empire_application/python_scripts/empire_wrapper.py b/applications/empire_application/python_scripts/empire_wrapper.py new file mode 100644 index 000000000000..aef6ae00775a --- /dev/null +++ b/applications/empire_application/python_scripts/empire_wrapper.py @@ -0,0 +1,381 @@ +from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 +# import libraries +from KratosMultiphysics import * +from KratosMultiphysics.EmpireApplication import * +import ctypes as ctp +import os + +CheckForPreviousImport() + +class EmpireWrapper: + # Source of Implementation: https://code.activestate.com/recipes/52558/ + # storage for the instance reference + __instance = None + + def __init__(self): + """ Create singleton instance """ + # Check whether we already have an instance + if EmpireWrapper.__instance is None: + # Create and remember instance + EmpireWrapper.__instance = EmpireWrapper.__EmpireWrapper() + + def __getattr__(self, attr): + """ Delegate access to implementation """ + return getattr(self.__instance, attr) + + def __setattr__(self, attr, value): + """ Delegate access to implementation """ + return setattr(self.__instance, attr, value) + + class __EmpireWrapper: + # Wrapper for the EMPIRE API (/EMPIRE-Core/EMPIRE_API/src/include/EMPIRE_API.h) + # Implemented as Singleton, bcs otherwise the EMPIRE library can be imported several times + ##### Constructor ##### + # ------------------------------------------------------------------------------------------------- + def __init__(self): + self.model_parts = {} + self._LoadEmpireLibrary() + # ------------------------------------------------------------------------------------------------- + + ##### Public Functions ##### + # ------------------------------------------------------------------------------------------------- + def Connect(self, xml_input_file): + ''' Establishes the necessary connection with the Emperor ''' + self.libempire_api.EMPIRE_API_Connect(xml_input_file.encode()) + print("::EMPIRE:: Connected") + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def Disconnect(self): + ''' Performs disconnection and finalization operations to the Emperor ''' + self.libempire_api.EMPIRE_API_Disconnect() + print("::EMPIRE:: Disconnected") + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def SendMesh(self, mesh_name, model_part): + ''' Send the mesh to the server + \param[in] name name of the mesh + \param[in] numNodes number of nodes + \param[in] numElems number of elements + \param[in] nodes coordinates of all nodes + \param[in] nodeIDs IDs of all nodes + \param[in] numNodesPerElem number of nodes per element + \param[in] elems connectivity table of all elements + + void EMPIRE_API_sendMesh(char *name, int numNodes, int numElems, double *nodes, int *nodeIDs, + int *numNodesPerElem, int *elems); ''' + # mesh_name: name of mesh in the emperor input + + # Save the ModelPart for data-field exchange later + self._SaveModelPart(mesh_name, model_part) + + # extract interface mesh information + numNodes = []; numElems = [] + nodeCoors = []; nodeIDs = [] + numNodesPerElem = []; elemTable = [] + self._GetMesh(model_part, numNodes, numElems, nodeCoors, nodeIDs, numNodesPerElem, elemTable) + + # convert python lists to ctypes, required for empire-function call + c_numNodes = (ctp.c_int * len(numNodes))(*numNodes) + c_numElems = (ctp.c_int * len(numElems))(*numElems) + c_nodeCoors = (ctp.c_double * len(nodeCoors))(*nodeCoors) + c_nodeIDs = (ctp.c_int * len(nodeIDs))(*nodeIDs) + c_numNodesPerElem = (ctp.c_int * len(numNodesPerElem))(*numNodesPerElem) + c_elemTable = (ctp.c_int * len(elemTable))(*elemTable) + + # send mesh to Emperor + self.libempire_api.EMPIRE_API_sendMesh("mesh_name.encode()", + c_numNodes[0], c_numElems[0], + c_nodeCoors, c_nodeIDs, + c_numNodesPerElem, c_elemTable) + print("::EMPIRE:: Sent Mesh") + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def ReceiveMesh(self, mesh_name, model_part): + ''' Recieve mesh from the server + \param[in] name name of the mesh + \param[in] numNodes number of nodes + \param[in] numElems number of elements + \param[in] nodes coordinates of all nodes + \param[in] nodeIDs IDs of all nodes + \param[in] numNodesPerElem number of nodes per element + \param[in] elems connectivity table of all elements + + void EMPIRE_API_recvMesh(char *name, int *numNodes, int *numElems, double **nodes, int **nodeIDs, + int **numNodesPerElem, int **elem); ''' + # mesh_name: name of mesh in the emperor input + + # Save the ModelPart for data-field exchange later + self._SaveModelPart(mesh_name, model_part) + + c_numNodes = ctp.pointer(ctp.c_int(0)) + c_numElems = ctp.pointer(ctp.c_int(0)) + c_nodeCoors = ctp.pointer(ctp.pointer(ctp.c_double(0))) + c_nodeIDs = ctp.pointer(ctp.pointer(ctp.c_int(0))) + c_numNodesPerElem = ctp.pointer(ctp.pointer(ctp.c_int(0))) + c_elemTable = ctp.pointer(ctp.pointer(ctp.c_int(0))) + + self.libempire_api.EMPIRE_API_recvMesh(mesh_name.encode(), + c_numNodes, c_numElems, + c_nodeCoors, c_nodeIDs, + c_numNodesPerElem, c_elemTable) + + numNodes = c_numNodes.contents.value + numElems = c_numElems.contents.value + nodeCoors = c_nodeCoors.contents + nodeIDs = c_nodeIDs.contents + numNodesPerElem = c_numNodesPerElem.contents + elemTable = c_elemTable.contents + + self._SetMesh(model_part, numNodes, numElems, nodeCoors, nodeIDs, numNodesPerElem, elemTable) + print("::EMPIRE:: Received Mesh") + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def SendDataField(self, mesh_name, data_field_name, kratos_variable): + ''' Send data field to the server + \param[in] name name of the field + \param[in] sizeOfArray size of the array (data field) + \param[in] dataField the data field to be sent + + void EMPIRE_API_sendDataField(char *name, int sizeOfArray, double *dataField); ''' + # mesh_name: name of mesh in the emperor input + # data_field_name: name of dataField in the emperor input + + # get ModelPart + model_part = self.model_parts[mesh_name] + + # extract data field from nodes + data_field = [] + self._GetDataField(model_part, kratos_variable, data_field) + + # convert list containg the data field to ctypes + c_data_field = (ctp.c_double * len(data_field))(*data_field) + c_size = len(c_data_field) + + # send data field to EMPIRE + self.libempire_api.EMPIRE_API_sendDataField("data_field_name.encode()", c_size, c_data_field) + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def ReceiveDataField(self, mesh_name, data_field_name, kratos_variable): + ''' Receive data field from the server + \param[in] name name of the field + \param[in] sizeOfArray size of the array (data field) + \param[out] dataField the data field to be received + + void EMPIRE_API_recvDataField(char *name, int sizeOfArray, double *dataField); ''' + # mesh_name: name of mesh in the emperor input + # data_field_name: name of dataField in the emperor input + + # get ModelPart + model_part = self.model_parts[mesh_name] + + # Determine Size of Variable + size_of_variable = self._SizeOfVariable(model_part, kratos_variable) + + # initialize vector storing the values + size_data_field = model_part.NumberOfNodes() * size_of_variable + c_size_data_field = ctp.c_int(size_data_field) + c_data_field = (ctp.c_double * size_data_field)(0) + + # receive data field from empire + self.libempire_api.EMPIRE_API_recvDataField(data_field_name.encode(), c_size_data_field, c_data_field) + + self._SetDataField(model_part, kratos_variable, c_data_field, size_of_variable) + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def SendArray(self, array_name, array_to_send): + ''' Send signal to the server + \param[in] name name of the signal + \param[in] sizeOfArray size of the array (signal) + \param[in] signal the signal + + void EMPIRE_API_sendSignal_double(char *name, int sizeOfArray, double *signal); ''' + # array_name: name of signal in the emperor input + + # convert array to ctypes + c_signal = (ctp.c_double * len(array_to_send))(*array_to_send) + c_size = len(c_signal) + + self.libempire_api.EMPIRE_API_sendSignal_double(array_name.encode(), c_size, c_signal) + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def ReceiveArray(self, array_name, array_size): + ''' Receive signal from the server + \param[in] name name of the signal + \param[in] sizeOfArray size of the array (signal) + \param[in] signal the signal + + void EMPIRE_API_recvSignal_double(char *name, int sizeOfArray, double *signal); ''' + # array_name: name of signal in the emperor input + + # initialize vector storing the values + c_signal = (ctp.c_double * array_size)(0) + + self.libempire_api.EMPIRE_API_recvSignal_double(array_name.encode(), array_size, c_signal) + + return self._ConvertToList(array_size, c_signal) + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def ReceiveConvergenceSignal(self): + '''Receive the convergence signal of an loop + \return 1 means convergence, 0 means non-convergence + + int EMPIRE_API_recvConvergenceSignal(); ''' + + return self.libempire_api.EMPIRE_API_recvConvergenceSignal() + # ------------------------------------------------------------------------------------------------- + + ##### Private Functions ##### + # ------------------------------------------------------------------------------------------------- + def _LoadEmpireLibrary(self): + if hasattr(self, 'libempire_api'): # the library has been loaded already + raise ImportError("The EMPIRE library must be loaded only once!") + + if "EMPIRE_API_LIBSO_ON_MACHINE" not in os.environ: + raise ImportError("The EMPIRE environment is not set!") + + try: # OpenMPI + self.libempire_api = ctp.CDLL(os.environ['EMPIRE_API_LIBSO_ON_MACHINE'], ctp.RTLD_GLOBAL) + print("::EMPIRE:: Using standard OpenMPI") + except: # Intel MPI or OpenMPI compiled with "–disable-dlopen" option + self.libempire_api = ctp.cdll.LoadLibrary(os.environ['EMPIRE_API_LIBSO_ON_MACHINE']) + print("::EMPIRE:: Using Intel MPI or OpenMPI compiled with \"–disable-dlopen\" option") + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def _GetMesh(self, model_part, num_nodes, num_elements, node_coords, node_IDs, num_nodes_per_element, element_table): + num_nodes.append(model_part.NumberOfNodes()) + num_elements.append(model_part.NumberOfElements()) + + for node in model_part.Nodes: + node_coords.append(node.X) + node_coords.append(node.Y) + node_coords.append(node.Z) + node_IDs.append(node.Id) + + for elem in model_part.Elements: + num_nodes_per_element.append(len(elem.GetNodes())) + for node in elem.GetNodes(): + element_table.append(node.Id) + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def _SetMesh(self, model_part, num_nodes, num_elements, node_coords, node_IDs, num_nodes_per_element, element_table): + # This function requires an empty ModelPart + # It constructs Nodes and Elements from what was received from EMPIRE + + # Some checks to validate input: + if model_part.NumberOfNodes() != 0: + raise Exception("ModelPart is not empty, it has some Nodes!") + if model_part.NumberOfElements() != 0: + raise Exception("ModelPart is not empty, it has some Elements!") + if model_part.NumberOfConditions() != 0: + raise Exception("ModelPart is not empty, it has some Conditions!") + + # Create Nodes + for i in range(num_nodes): + model_part.CreateNewNode(node_IDs[i], node_coords[3*i+0], node_coords[3*i+1], node_coords[3*i+2]) # Id, X, Y, Z + + # Create dummy Property for Element + model_part.AddProperties(Properties(1)) + prop = model_part.GetProperties()[1] + + element_table_counter = 0 + # Create Elements + for i in range(num_elements): + num_nodes_element = num_nodes_per_element[i] + if num_nodes_element == 2: + name_element = "Element2D2N" + elif num_nodes_element == 3: + name_element = "Element2D3N" + elif num_nodes_element == 4: # TODO how to distinguish from Tetras? + name_element = "Element2D4N" + else: + raise Exception("Wrong number of nodes for creating the element") + + element_nodes = [] + for j in range(num_nodes_element): + element_nodes.append(int(element_table[element_table_counter])) + element_table_counter += 1 + + model_part.CreateNewElement(name_element, i+1, element_nodes, prop) + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def _GetDataField(self, model_part, kratos_variable, data_field): + size_of_variable = self._SizeOfVariable(model_part, kratos_variable) + + for node in model_part.Nodes: + data_value = node.GetSolutionStepValue(kratos_variable) + + if size_of_variable == 1: + data_field.append(data_value) + else: + for i in range(size_of_variable): + data_field.append(data_value[i]) + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def _SetDataField(self, model_part, kratos_variable, data_field, size_of_variable): + # check if size of data field is correct + if len(data_field) != model_part.NumberOfNodes() * size_of_variable: + raise("ERROR: received data field has wrong size!") + + if size_of_variable > 1: + value = Vector(size_of_variable) + + i = 0 + # assign values to nodes of interface for current time step + for node in model_part.Nodes: + if size_of_variable == 1: + value = data_field[size_of_variable * i] + else: + for j in range(size_of_variable): + value[j] = data_field[size_of_variable * i + j] + + node.SetSolutionStepValue(kratos_variable, 0, value) + + i = i + 1 + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def _SizeOfVariable(self, model_part, kratos_variable): + # this function is very general, even though EMPIRE works with Scalar and Vector quantities only! + try: + first_node = next(iter(model_part.Nodes)) + value = first_node.GetSolutionStepValue(kratos_variable) + if (isinstance(value, float) or isinstance(value, int)): # Variable is a scalar + size_of_variable = 1 + else: + size_of_variable = len(first_node.GetSolutionStepValue(kratos_variable)) + except StopIteration: + raise TypeError("size_of_variable could not be determined") + + return size_of_variable + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def _SaveModelPart(self, mesh_name, model_part): + # Save the model_part for data-field exchange later + if mesh_name in self.model_parts: + raise ValueError("Mesh exsts already") + else: + self.model_parts.update({mesh_name : model_part}) + # ------------------------------------------------------------------------------------------------- + + # ------------------------------------------------------------------------------------------------- + def _ConvertToList(self, array_size, c_signal): + converted_list = [0.0] * array_size # preallocate + + for i in range(array_size): + converted_list[i] = c_signal[i] + + return converted_list + # ------------------------------------------------------------------------------------------------- diff --git a/applications/empire_application/python_scripts/empire_wrapper_ale.py b/applications/empire_application/python_scripts/legacy_empire_wrappers/empire_wrapper_ale.py similarity index 100% rename from applications/empire_application/python_scripts/empire_wrapper_ale.py rename to applications/empire_application/python_scripts/legacy_empire_wrappers/empire_wrapper_ale.py diff --git a/applications/empire_application/python_scripts/empire_wrapper_embedded.py b/applications/empire_application/python_scripts/legacy_empire_wrappers/empire_wrapper_embedded.py similarity index 100% rename from applications/empire_application/python_scripts/empire_wrapper_embedded.py rename to applications/empire_application/python_scripts/legacy_empire_wrappers/empire_wrapper_embedded.py diff --git a/applications/empire_application/python_scripts/empire_wrapper_st_tum_CFD.py b/applications/empire_application/python_scripts/legacy_empire_wrappers/empire_wrapper_st_tum_CFD.py similarity index 100% rename from applications/empire_application/python_scripts/empire_wrapper_st_tum_CFD.py rename to applications/empire_application/python_scripts/legacy_empire_wrappers/empire_wrapper_st_tum_CFD.py diff --git a/applications/empire_application/python_scripts/empire_wrapper_st_tum_CSM.py b/applications/empire_application/python_scripts/legacy_empire_wrappers/empire_wrapper_st_tum_CSM.py similarity index 100% rename from applications/empire_application/python_scripts/empire_wrapper_st_tum_CSM.py rename to applications/empire_application/python_scripts/legacy_empire_wrappers/empire_wrapper_st_tum_CSM.py diff --git a/applications/empire_application/test_examples/wrapper_example_basic_array/emperorInput.xml b/applications/empire_application/test_examples/wrapper_example_basic_array/emperorInput.xml new file mode 100644 index 000000000000..c149139f3093 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_array/emperorInput.xml @@ -0,0 +1,87 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + server.port + INFO + + diff --git a/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_1.py b/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_1.py new file mode 100644 index 000000000000..a0f7bd6add2e --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_1.py @@ -0,0 +1,26 @@ +from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +from KratosMultiphysics import * +# EMPIRE +import KratosMultiphysics.EmpireApplication as KratosEmpire +from ctypes import cdll +import os +import ctypes as ctp + +print("This is kratos_client_1") + +print("Starting to initialize Empire") +import empire_wrapper +print("Import Successfull") +empire = empire_wrapper.EmpireWrapper() +print("Wrapper Created") +empire.Connect("kratos_client_1.xml") + +array_to_send = [1.5,2.6,3,4,5] +empire.SendArray("array_1", array_to_send) +print("Sent Array:", array_to_send) + +received_array = empire.ReceiveArray("array_2", 10) +print("Received Array:", received_array) + +empire.Disconnect() \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_1.xml b/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_1.xml new file mode 100644 index 000000000000..12b02b69f109 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_1.xml @@ -0,0 +1,11 @@ + + + + + signal + + + server.port + INFO + + \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_2.py b/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_2.py new file mode 100644 index 000000000000..d0598e0c0fb6 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_2.py @@ -0,0 +1,26 @@ +from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +from KratosMultiphysics import * +# EMPIRE +import KratosMultiphysics.EmpireApplication as KratosEmpire +from ctypes import cdll +import os +import ctypes as ctp + +print("This is kratos_client_2") + +print("Starting to initialize Empire") +import empire_wrapper +print("Import Successfull") +empire = empire_wrapper.EmpireWrapper() +print("Wrapper Created") +empire.Connect("kratos_client_2.xml") + +received_array = empire.ReceiveArray("array_1", 5) +print("Received Array:", received_array) + +array_to_send = [1,2,3,4,5,9.118,8,7,6,5] +empire.SendArray("array_2", array_to_send) +print("Sent Array:", array_to_send) + +empire.Disconnect() \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_2.xml b/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_2.xml new file mode 100644 index 000000000000..d5525a483331 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_array/kratos_client_2.xml @@ -0,0 +1,11 @@ + + + + + signal + + + server.port + INFO + + \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_basic_array/run_wrapper_example.sh b/applications/empire_application/test_examples/wrapper_example_basic_array/run_wrapper_example.sh new file mode 100644 index 000000000000..86e44839c24d --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_array/run_wrapper_example.sh @@ -0,0 +1,63 @@ +#!/bin/bash +# This script is used to execute the example + +# ATTENTION make sure to set the EMPIRE-environment before running this script (e.g. startEMPIRE) +if [ -z ${EMPIRE_API_LIBSO_ON_MACHINE+x} ]; then + echo "EMPIRE Environment in not set!"; + return 1 +fi + +# Options for how to run the example +# use_intel_mpi: +# true: If standard OpenMPI is used +# false: If Intel MPI or OpenMPI compiled with the "–disable-dlopen" option is used +use_intel_mpi=false + +# run_in_xterm +# true: spawn three xterm terminals for each process (1 for EMPIRE and 2 for the Kratos Clients) +# false: writes output into files +run_in_xterm=true + +# ompi-server path: this is the ABSOLUTE path to the ompi-server-file. +# Unused if Intel MPI or OpenMPI compiled with the "–disable-dlopen" option is used +# To start a server: "ompi-server -r ~/ompi_server.port" +ompi_server_file_path="/home/USERNAME/.ompi_server.port" + +if $run_in_xterm; then + if $use_intel_mpi; then + echo "Using Intel MPI or OpenMPI compiled with the \"–disable-dlopen\" option and running with XTerm" + xterm -hold -e mpiexec -np 1 Emperor emperorInput.xml & EPID=$! + sleep 0.8s + xterm -hold -e mpiexec -np 1 python3 kratos_client_1.py & + sleep 0.8s + xterm -hold -e mpiexec -np 1 python3 kratos_client_2.py & + wait $EPID + else + echo "Using OpenMPI and running with XTerm" + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path Emperor emperorInput.xml & EPID=$! + sleep 0.8s + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_1.py & + sleep 0.8s + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_2.py & + wait $EPID + fi +else + if $use_intel_mpi; then + echo "Using Intel MPI or OpenMPI compiled with the \"–disable-dlopen\" option and writting output to logfiles" + mpiexec -np 1 Emperor emperorInput.xml > Emperor.log 2> Emperor.err & EPID=$! + sleep 0.4s + mpiexec -np 1 python3 kratos_client_1.py > kratos_client_1.log 2>kratos_client_1.err & + sleep 0.4s + mpiexec -np 1 python3 kratos_client_2.py > kratos_client_2.log 2>kratos_client_2.err & + wait $EPID + else + echo "Using OpenMPI and writting output to logfiles" + mpiexec -np 1 --ompi-server file:$ompi_server_file_path Emperor emperorInput.xml > Emperor.log 2> Emperor.err & EPID=$! + sleep 0.4s + mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_1.py > kratos_client_1.log 2>kratos_client_1.err & + sleep 0.4s + mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_2.py > kratos_client_2.log 2>kratos_client_2.err & + wait $EPID + fi +fi + diff --git a/applications/empire_application/test_examples/wrapper_example_basic_field/emperorInput.xml b/applications/empire_application/test_examples/wrapper_example_basic_field/emperorInput.xml new file mode 100644 index 000000000000..7645a7292e62 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_field/emperorInput.xml @@ -0,0 +1,45 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + server.port + INFO + + diff --git a/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_1.py b/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_1.py new file mode 100644 index 000000000000..6f52d0b5552c --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_1.py @@ -0,0 +1,23 @@ +from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +from KratosMultiphysics import * +# EMPIRE +import KratosMultiphysics.EmpireApplication as KratosEmpire +from ctypes import cdll +import os +import ctypes as ctp + +print("This is kratos_client_1") + +model_part = ModelPart("MyModelPart") + +print("Starting to initialize Empire") +import empire_wrapper +print("Import Successfull") +empire = empire_wrapper.EmpireWrapper() +print("Wrapper Created") +empire.Connect("kratos_client_1.xml") + +empire.SendMesh("myMesh1",model_part) + +empire.Disconnect() \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_1.xml b/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_1.xml new file mode 100644 index 000000000000..44dfddba9777 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_1.xml @@ -0,0 +1,10 @@ + + + + + + + server.port + INFO + + \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_2.py b/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_2.py new file mode 100644 index 000000000000..eea7f3a7d6a7 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_2.py @@ -0,0 +1,23 @@ +from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +from KratosMultiphysics import * +# EMPIRE +import KratosMultiphysics.EmpireApplication as KratosEmpire +from ctypes import cdll +import os +import ctypes as ctp + +print("This is kratos_client_2") + +model_part = ModelPart("MyModelPart") + +print("Starting to initialize Empire") +import empire_wrapper +print("Import Successfull") +empire = empire_wrapper.EmpireWrapper() +print("Wrapper Created") +empire.Connect("kratos_client_2.xml") + +empire.SendMesh("myMesh2", model_part) + +empire.Disconnect() \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_2.xml b/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_2.xml new file mode 100644 index 000000000000..b8abbd5c2cf4 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_field/kratos_client_2.xml @@ -0,0 +1,10 @@ + + + + + + + server.port + INFO + + \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_basic_field/run_wrapper_example.sh b/applications/empire_application/test_examples/wrapper_example_basic_field/run_wrapper_example.sh new file mode 100644 index 000000000000..86e44839c24d --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_basic_field/run_wrapper_example.sh @@ -0,0 +1,63 @@ +#!/bin/bash +# This script is used to execute the example + +# ATTENTION make sure to set the EMPIRE-environment before running this script (e.g. startEMPIRE) +if [ -z ${EMPIRE_API_LIBSO_ON_MACHINE+x} ]; then + echo "EMPIRE Environment in not set!"; + return 1 +fi + +# Options for how to run the example +# use_intel_mpi: +# true: If standard OpenMPI is used +# false: If Intel MPI or OpenMPI compiled with the "–disable-dlopen" option is used +use_intel_mpi=false + +# run_in_xterm +# true: spawn three xterm terminals for each process (1 for EMPIRE and 2 for the Kratos Clients) +# false: writes output into files +run_in_xterm=true + +# ompi-server path: this is the ABSOLUTE path to the ompi-server-file. +# Unused if Intel MPI or OpenMPI compiled with the "–disable-dlopen" option is used +# To start a server: "ompi-server -r ~/ompi_server.port" +ompi_server_file_path="/home/USERNAME/.ompi_server.port" + +if $run_in_xterm; then + if $use_intel_mpi; then + echo "Using Intel MPI or OpenMPI compiled with the \"–disable-dlopen\" option and running with XTerm" + xterm -hold -e mpiexec -np 1 Emperor emperorInput.xml & EPID=$! + sleep 0.8s + xterm -hold -e mpiexec -np 1 python3 kratos_client_1.py & + sleep 0.8s + xterm -hold -e mpiexec -np 1 python3 kratos_client_2.py & + wait $EPID + else + echo "Using OpenMPI and running with XTerm" + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path Emperor emperorInput.xml & EPID=$! + sleep 0.8s + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_1.py & + sleep 0.8s + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_2.py & + wait $EPID + fi +else + if $use_intel_mpi; then + echo "Using Intel MPI or OpenMPI compiled with the \"–disable-dlopen\" option and writting output to logfiles" + mpiexec -np 1 Emperor emperorInput.xml > Emperor.log 2> Emperor.err & EPID=$! + sleep 0.4s + mpiexec -np 1 python3 kratos_client_1.py > kratos_client_1.log 2>kratos_client_1.err & + sleep 0.4s + mpiexec -np 1 python3 kratos_client_2.py > kratos_client_2.log 2>kratos_client_2.err & + wait $EPID + else + echo "Using OpenMPI and writting output to logfiles" + mpiexec -np 1 --ompi-server file:$ompi_server_file_path Emperor emperorInput.xml > Emperor.log 2> Emperor.err & EPID=$! + sleep 0.4s + mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_1.py > kratos_client_1.log 2>kratos_client_1.err & + sleep 0.4s + mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_2.py > kratos_client_2.log 2>kratos_client_2.err & + wait $EPID + fi +fi + diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim/emperorInput.xml b/applications/empire_application/test_examples/wrapper_example_field_CoSim/emperorInput.xml new file mode 100644 index 000000000000..7f58cbff08eb --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim/emperorInput.xml @@ -0,0 +1,108 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + server.port + DEBUG + + diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_1.py b/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_1.py new file mode 100644 index 000000000000..dfe8fe3c0ff2 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_1.py @@ -0,0 +1,59 @@ +from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +from KratosMultiphysics import * +# EMPIRE +import KratosMultiphysics.EmpireApplication as KratosEmpire +from ctypes import cdll +import os +import ctypes as ctp +import numpy as np + +def SetNodalValues(counter): # Somehow Modify the Nodal Values + for node in model_part.Nodes: + value = node.GetSolutionStepValue(TEMPERATURE) - counter**2 + node.SetSolutionStepValue(DISPLACEMENT, (value, value+counter, value+counter*2)) + +print("This is kratos_client_1") + +model_part = ModelPart("MyModelPart") +model_part.AddNodalSolutionStepVariable(DISPLACEMENT) +model_part.AddNodalSolutionStepVariable(TEMPERATURE) + +nodes = np.array([0.0,0.0,0.0, 1.0,0.0,0.0, 2.0,0.0,0.0, 3.0,0.0,0.0, 0.0,1.0,0.0, 1.0,1.0,0.0, 2.0,1.0,0.0, 3.0,1.0,0.0]) +elements = np.array([1,2,6,5, 2,3,7,6, 3,4,8,7]) + +# Creating the mesh in the model part +print("Mesh 1 ::::: Length of Nodes = ",int(len(nodes)/3)) +print("Mesh 1 ::::: Length of Elements = ",int(len(elements)/4)) +print("Mesh 1 ::::: Maximum entry in elements vector = ", np.max(elements)) +for i in range(0,int(len(nodes)/3)): + model_part.CreateNewNode(i+1, nodes[3*i+0], nodes[3*i+1], nodes[3*i+2]) +print("Mesh 1 ::::: Finished adding nodes to model part !!") + +# Creating elements with the above nodes +model_part.AddProperties(Properties(1)) +print("Mesh 1 ::::: Finished adding Properties to model part !!") +prp = model_part.GetProperties()[1] +print("Mesh 1 ::::: Finished extracting properties from the model part !!") + +for i in range(0,int(len(elements)/4)): + sys.stdout.flush() + model_part.CreateNewElement("Element2D4N", i+1,[int(elements[4*i+0]),int(elements[4*i+1]),int(elements[4*i+2]),int(elements[4*i+3])], prp) +print("Mesh 1 ::::: Finished Adding Elements to model part !!") + +print("Starting to initialize Empire") +import empire_wrapper +print("Import Successfull") +empire = empire_wrapper.EmpireWrapper() +print("Wrapper Created") +empire.Connect("kratos_client_1.xml") + +empire.SendMesh("myMesh1", model_part) + +for i in range(10): + empire.SendDataField("myMesh1", "displacement", DISPLACEMENT) + empire.ReceiveDataField("myMesh1", "temperature", TEMPERATURE) + + SetNodalValues(i) + +empire.Disconnect() \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_1.xml b/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_1.xml new file mode 100644 index 000000000000..4ae82ef3058f --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_1.xml @@ -0,0 +1,11 @@ + + + + + field + + + server.port + INFO + + \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_2.py b/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_2.py new file mode 100644 index 000000000000..019f11c7e4ad --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_2.py @@ -0,0 +1,35 @@ +from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +from KratosMultiphysics import * +# EMPIRE +import KratosMultiphysics.EmpireApplication as KratosEmpire +from ctypes import cdll +import os +import ctypes as ctp + +def SetNodalValues(counter): # Somehow Modify the Nodal Values + for node in model_part.Nodes: + value = sum(node.GetSolutionStepValue(VELOCITY)) + counter + node.SetSolutionStepValue(PRESSURE, value) + +print("This is kratos_client_2") + +model_part = ModelPart("MyModelPart") +model_part.AddNodalSolutionStepVariable(VELOCITY) +model_part.AddNodalSolutionStepVariable(PRESSURE) + +print("Starting to initialize Empire") +import empire_wrapper +print("Import Successfull") +empire = empire_wrapper.EmpireWrapper() +print("Wrapper Created") +empire.Connect("kratos_client_2.xml") + +empire.ReceiveMesh("myMesh2", model_part) + +for i in range(10): + empire.ReceiveDataField("myMesh2", "velocity", VELOCITY) + SetNodalValues(i) + empire.SendDataField("myMesh2", "pressure", PRESSURE) + +empire.Disconnect() \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_2.xml b/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_2.xml new file mode 100644 index 000000000000..98015239d064 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim/kratos_client_2.xml @@ -0,0 +1,11 @@ + + + + + field + + + server.port + INFO + + \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim/run_wrapper_example.sh b/applications/empire_application/test_examples/wrapper_example_field_CoSim/run_wrapper_example.sh new file mode 100644 index 000000000000..86e44839c24d --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim/run_wrapper_example.sh @@ -0,0 +1,63 @@ +#!/bin/bash +# This script is used to execute the example + +# ATTENTION make sure to set the EMPIRE-environment before running this script (e.g. startEMPIRE) +if [ -z ${EMPIRE_API_LIBSO_ON_MACHINE+x} ]; then + echo "EMPIRE Environment in not set!"; + return 1 +fi + +# Options for how to run the example +# use_intel_mpi: +# true: If standard OpenMPI is used +# false: If Intel MPI or OpenMPI compiled with the "–disable-dlopen" option is used +use_intel_mpi=false + +# run_in_xterm +# true: spawn three xterm terminals for each process (1 for EMPIRE and 2 for the Kratos Clients) +# false: writes output into files +run_in_xterm=true + +# ompi-server path: this is the ABSOLUTE path to the ompi-server-file. +# Unused if Intel MPI or OpenMPI compiled with the "–disable-dlopen" option is used +# To start a server: "ompi-server -r ~/ompi_server.port" +ompi_server_file_path="/home/USERNAME/.ompi_server.port" + +if $run_in_xterm; then + if $use_intel_mpi; then + echo "Using Intel MPI or OpenMPI compiled with the \"–disable-dlopen\" option and running with XTerm" + xterm -hold -e mpiexec -np 1 Emperor emperorInput.xml & EPID=$! + sleep 0.8s + xterm -hold -e mpiexec -np 1 python3 kratos_client_1.py & + sleep 0.8s + xterm -hold -e mpiexec -np 1 python3 kratos_client_2.py & + wait $EPID + else + echo "Using OpenMPI and running with XTerm" + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path Emperor emperorInput.xml & EPID=$! + sleep 0.8s + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_1.py & + sleep 0.8s + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_2.py & + wait $EPID + fi +else + if $use_intel_mpi; then + echo "Using Intel MPI or OpenMPI compiled with the \"–disable-dlopen\" option and writting output to logfiles" + mpiexec -np 1 Emperor emperorInput.xml > Emperor.log 2> Emperor.err & EPID=$! + sleep 0.4s + mpiexec -np 1 python3 kratos_client_1.py > kratos_client_1.log 2>kratos_client_1.err & + sleep 0.4s + mpiexec -np 1 python3 kratos_client_2.py > kratos_client_2.log 2>kratos_client_2.err & + wait $EPID + else + echo "Using OpenMPI and writting output to logfiles" + mpiexec -np 1 --ompi-server file:$ompi_server_file_path Emperor emperorInput.xml > Emperor.log 2> Emperor.err & EPID=$! + sleep 0.4s + mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_1.py > kratos_client_1.log 2>kratos_client_1.err & + sleep 0.4s + mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_2.py > kratos_client_2.log 2>kratos_client_2.err & + wait $EPID + fi +fi + diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/emperorInput.xml b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/emperorInput.xml new file mode 100644 index 000000000000..d5a4e140eb0a --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/emperorInput.xml @@ -0,0 +1,139 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + server.port + INFO + + diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_1.py b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_1.py new file mode 100644 index 000000000000..d67ce8dbd095 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_1.py @@ -0,0 +1,68 @@ +from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +from KratosMultiphysics import * +# EMPIRE +import KratosMultiphysics.EmpireApplication as KratosEmpire +from ctypes import cdll +import os +import ctypes as ctp +import numpy as np + +def SetNodalValues(counter): # Somehow Modify the Nodal Values + for node in model_part.Nodes: + value = node.GetSolutionStepValue(TEMPERATURE) - counter**2 + node.SetSolutionStepValue(DISPLACEMENT, (value, value+counter, value+counter*2)) + +print("This is kratos_client_1") + +model_part = ModelPart("MyModelPart") +model_part.AddNodalSolutionStepVariable(DISPLACEMENT) +model_part.AddNodalSolutionStepVariable(TEMPERATURE) + +nodes = np.array([0.0,0.0,0.0, 1.0,0.0,0.0, 2.0,0.0,0.0, 3.0,0.0,0.0, 0.0,1.0,0.0, 1.0,1.0,0.0, 2.0,1.0,0.0, 3.0,1.0,0.0]) +elements = np.array([1,2,6,5, 2,3,7,6, 3,4,8,7]) + +# Creating the mesh in the model part +print("Mesh 1 ::::: Length of Nodes = ",int(len(nodes)/3)) +print("Mesh 1 ::::: Length of Elements = ",int(len(elements)/4)) +print("Mesh 1 ::::: Maximum entry in elements vector = ", np.max(elements)) +for i in range(0,int(len(nodes)/3)): + model_part.CreateNewNode(i+1, nodes[3*i+0], nodes[3*i+1], nodes[3*i+2]) +print("Mesh 1 ::::: Finished adding nodes to model part !!") + +# Creating elements with the above nodes +model_part.AddProperties(Properties(1)) +print("Mesh 1 ::::: Finished adding Properties to model part !!") +prp = model_part.GetProperties()[1] +print("Mesh 1 ::::: Finished extracting properties from the model part !!") + +for i in range(0,int(len(elements)/4)): + sys.stdout.flush() + model_part.CreateNewElement("Element2D4N", i+1,[int(elements[4*i+0]),int(elements[4*i+1]),int(elements[4*i+2]),int(elements[4*i+3])], prp) +print("Mesh 1 ::::: Finished Adding Elements to model part !!") + +for node in model_part.Nodes: + node.SetSolutionStepValue(DISPLACEMENT, (1.1,2.2,3.3)) + +print("Starting to initialize Empire") +import empire_wrapper +print("Import Successfull") +empire = empire_wrapper.EmpireWrapper() +print("Wrapper Created") +empire.Connect("kratos_client_1.xml") + +empire.SendMesh("myMesh1", model_part) + +for i in range(10): + print("STEP:", i) + j = 1 + is_converged = False + while not(is_converged): + print(" Iteration:", j) + empire.SendDataField("myMesh1", "displacement", DISPLACEMENT) + empire.ReceiveDataField("myMesh1", "temperature", TEMPERATURE) + SetNodalValues(i) + is_converged = empire.ReceiveConvergenceSignal() + j += 1 + +empire.Disconnect() \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_1.xml b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_1.xml new file mode 100644 index 000000000000..4ae82ef3058f --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_1.xml @@ -0,0 +1,11 @@ + + + + + field + + + server.port + INFO + + \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_2.py b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_2.py new file mode 100644 index 000000000000..61d696d0d293 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_2.py @@ -0,0 +1,65 @@ +from __future__ import print_function, absolute_import, division # makes KratosMultiphysics backward compatible with python 2.6 and 2.7 + +from KratosMultiphysics import * +# EMPIRE +import KratosMultiphysics.EmpireApplication as KratosEmpire +from ctypes import cdll +import os +import ctypes as ctp +import numpy as np + +def SetNodalValues(counter): # Somehow Modify the Nodal Values + for node in model_part.Nodes: + value = sum(node.GetSolutionStepValue(VELOCITY)) + counter + node.SetSolutionStepValue(PRESSURE, value) + +print("This is kratos_client_2") + +model_part = ModelPart("MyModelPart") +model_part.AddNodalSolutionStepVariable(VELOCITY) +model_part.AddNodalSolutionStepVariable(PRESSURE) + +nodes = np.array([0.0,0.0,0.0, 1.0,0.0,0.0, 2.0,0.0,0.0, 3.0,0.0,0.0, 0.0,1.0,0.0, 1.0,1.0,0.0, 2.0,1.0,0.0, 3.0,1.0,0.0]) +elements = np.array([1,2,6,5, 2,3,7,6, 3,4,8,7]) + +# Creating the mesh in the model part +print("Mesh 2 ::::: Length of Nodes = ",int(len(nodes)/3)) +print("Mesh 2 ::::: Length of Elements = ",int(len(elements)/4)) +print("Mesh 2 ::::: Maximum entry in elements vector = ", np.max(elements)) +for i in range(0,int(len(nodes)/3)): + model_part.CreateNewNode(i+1, nodes[3*i+0], nodes[3*i+1], nodes[3*i+2]) +print("Mesh 2 ::::: Finished adding nodes to model part !!") + +# Creating elements with the above nodes +model_part.AddProperties(Properties(1)) +print("Mesh 2 ::::: Finished adding Properties to model part !!") +prp = model_part.GetProperties()[1] +print("Mesh 2 ::::: Finished extracting properties from the model part !!") + +for i in range(0,int(len(elements)/4)): + sys.stdout.flush() + model_part.CreateNewElement("Element2D4N", i+1,[int(elements[4*i+0]),int(elements[4*i+1]),int(elements[4*i+2]),int(elements[4*i+3])], prp) +print("Mesh 2 ::::: Finished Adding Elements to model part !!") + +print("Starting to initialize Empire") +import empire_wrapper +print("Import Successfull") +empire = empire_wrapper.EmpireWrapper() +print("Wrapper Created") +empire.Connect("kratos_client_2.xml") + +empire.SendMesh("myMesh2", model_part) + +for i in range(10): + print("STEP:", i) + j = 1 + is_converged = False + while not(is_converged): + print(" Iteration:", j) + empire.ReceiveDataField("myMesh2", "velocity", VELOCITY) + SetNodalValues(i) + empire.SendDataField("myMesh2", "pressure", PRESSURE) + is_converged = empire.ReceiveConvergenceSignal() + j += 1 + +empire.Disconnect() \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_2.xml b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_2.xml new file mode 100644 index 000000000000..98015239d064 --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/kratos_client_2.xml @@ -0,0 +1,11 @@ + + + + + field + + + server.port + INFO + + \ No newline at end of file diff --git a/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/run_wrapper_example.sh b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/run_wrapper_example.sh new file mode 100644 index 000000000000..86e44839c24d --- /dev/null +++ b/applications/empire_application/test_examples/wrapper_example_field_CoSim_Iterative/run_wrapper_example.sh @@ -0,0 +1,63 @@ +#!/bin/bash +# This script is used to execute the example + +# ATTENTION make sure to set the EMPIRE-environment before running this script (e.g. startEMPIRE) +if [ -z ${EMPIRE_API_LIBSO_ON_MACHINE+x} ]; then + echo "EMPIRE Environment in not set!"; + return 1 +fi + +# Options for how to run the example +# use_intel_mpi: +# true: If standard OpenMPI is used +# false: If Intel MPI or OpenMPI compiled with the "–disable-dlopen" option is used +use_intel_mpi=false + +# run_in_xterm +# true: spawn three xterm terminals for each process (1 for EMPIRE and 2 for the Kratos Clients) +# false: writes output into files +run_in_xterm=true + +# ompi-server path: this is the ABSOLUTE path to the ompi-server-file. +# Unused if Intel MPI or OpenMPI compiled with the "–disable-dlopen" option is used +# To start a server: "ompi-server -r ~/ompi_server.port" +ompi_server_file_path="/home/USERNAME/.ompi_server.port" + +if $run_in_xterm; then + if $use_intel_mpi; then + echo "Using Intel MPI or OpenMPI compiled with the \"–disable-dlopen\" option and running with XTerm" + xterm -hold -e mpiexec -np 1 Emperor emperorInput.xml & EPID=$! + sleep 0.8s + xterm -hold -e mpiexec -np 1 python3 kratos_client_1.py & + sleep 0.8s + xterm -hold -e mpiexec -np 1 python3 kratos_client_2.py & + wait $EPID + else + echo "Using OpenMPI and running with XTerm" + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path Emperor emperorInput.xml & EPID=$! + sleep 0.8s + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_1.py & + sleep 0.8s + xterm -hold -e mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_2.py & + wait $EPID + fi +else + if $use_intel_mpi; then + echo "Using Intel MPI or OpenMPI compiled with the \"–disable-dlopen\" option and writting output to logfiles" + mpiexec -np 1 Emperor emperorInput.xml > Emperor.log 2> Emperor.err & EPID=$! + sleep 0.4s + mpiexec -np 1 python3 kratos_client_1.py > kratos_client_1.log 2>kratos_client_1.err & + sleep 0.4s + mpiexec -np 1 python3 kratos_client_2.py > kratos_client_2.log 2>kratos_client_2.err & + wait $EPID + else + echo "Using OpenMPI and writting output to logfiles" + mpiexec -np 1 --ompi-server file:$ompi_server_file_path Emperor emperorInput.xml > Emperor.log 2> Emperor.err & EPID=$! + sleep 0.4s + mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_1.py > kratos_client_1.log 2>kratos_client_1.err & + sleep 0.4s + mpiexec -np 1 --ompi-server file:$ompi_server_file_path python3 kratos_client_2.py > kratos_client_2.log 2>kratos_client_2.err & + wait $EPID + fi +fi + diff --git a/applications/swimming_DEM_application/python_scripts/pfem_fluid_ready_for_dem_coupling.py b/applications/swimming_DEM_application/python_scripts/pfem_fluid_ready_for_dem_coupling.py index ada3f67923aa..997681143149 100644 --- a/applications/swimming_DEM_application/python_scripts/pfem_fluid_ready_for_dem_coupling.py +++ b/applications/swimming_DEM_application/python_scripts/pfem_fluid_ready_for_dem_coupling.py @@ -12,7 +12,7 @@ import KratosMultiphysics import KratosMultiphysics.SolidMechanicsApplication as KratosSolid import KratosMultiphysics.ExternalSolversApplication as KratosSolvers -import KratosMultiphysics.PfemBaseApplication as KratosPfemBase +import KratosMultiphysics.PfemApplication as KratosPfem import KratosMultiphysics.ContactMechanicsApplication as KratosContact import KratosMultiphysics.PfemSolidMechanicsApplication as KratosPfemSolid import KratosMultiphysics.PfemFluidDynamicsApplication as KratosPfemFluid diff --git a/applications/trilinos_application/CMakeLists.txt b/applications/trilinos_application/CMakeLists.txt index e34658ad1ff2..dc53f9ff8081 100644 --- a/applications/trilinos_application/CMakeLists.txt +++ b/applications/trilinos_application/CMakeLists.txt @@ -6,7 +6,6 @@ include_directories( ${CMAKE_SOURCE_DIR}/kratos ) include_directories( ${CMAKE_SOURCE_DIR}/applications/ ) #dependecies on other application -- TRILINOS specific -include_directories( ${CMAKE_SOURCE_DIR}/applications/incompressible_fluid_application ) include_directories( ${CMAKE_SOURCE_DIR}/applications/FluidDynamicsApplication ) include_directories( ${CMAKE_CURRENT_SOURCE_DIR}/custom_external_libraries ) diff --git a/applications/trilinos_application/custom_python/add_trilinos_convergence_criterias_to_python.cpp b/applications/trilinos_application/custom_python/add_trilinos_convergence_criterias_to_python.cpp index 50c5dd3b95da..4b752fdf3769 100644 --- a/applications/trilinos_application/custom_python/add_trilinos_convergence_criterias_to_python.cpp +++ b/applications/trilinos_application/custom_python/add_trilinos_convergence_criterias_to_python.cpp @@ -1,14 +1,14 @@ -// KRATOS _____ _ _ _ -// |_ _| __(_) (_)_ __ ___ ___ +// KRATOS _____ _ _ _ +// |_ _| __(_) (_)_ __ ___ ___ // | || '__| | | | '_ \ / _ \/ __| -// | || | | | | | | | | (_) \__ +// | || | | | | | | | | (_) \__ // |_||_| |_|_|_|_| |_|\___/|___/ APPLICATION // -// License: BSD License +// License: BSD License // Kratos default license: kratos/license.txt // // Main authors: Riccardo Rossi -// +// // System includes @@ -90,18 +90,18 @@ void AddConvergenceCriterias() class_< TrilinosDisplacementCriteria, bases< TrilinosConvergenceCriteria >, boost::noncopyable > - ("TrilinosDisplacementCriteria", init< double, double, Epetra_MpiComm& >()); + ("TrilinosDisplacementCriteria", init< double, double >()); class_< TrilinosUPCriteria, bases< TrilinosConvergenceCriteria >, boost::noncopyable > - ("TrilinosUPCriteria", init< double, double, double, double, Epetra_MpiComm& >()); + ("TrilinosUPCriteria", init< double, double, double, double >()); class_< ResidualCriteria, bases< TrilinosConvergenceCriteria >, boost::noncopyable > ("TrilinosResidualCriteria", init< TrilinosSparseSpaceType::DataType, TrilinosSparseSpaceType::DataType >()); - + class_, bases< TrilinosConvergenceCriteria >, boost::noncopyable > diff --git a/applications/trilinos_application/custom_python/add_trilinos_strategies_to_python.cpp b/applications/trilinos_application/custom_python/add_trilinos_strategies_to_python.cpp index 1b5d5658e16d..7707b3dc621e 100644 --- a/applications/trilinos_application/custom_python/add_trilinos_strategies_to_python.cpp +++ b/applications/trilinos_application/custom_python/add_trilinos_strategies_to_python.cpp @@ -75,10 +75,6 @@ // #include "external_includes/ml_solver.h" //configuration files -#include "incompressible_fluid_application/custom_strategies/strategies/solver_configuration.h" -//~ #include "custom_strategies/strategies/trilinos_fractionalstep_configuration.h" -#include "incompressible_fluid_application/custom_strategies/strategies/fractional_step_strategy.h" -#include "incompressible_fluid_application/incompressible_fluid_application.h" #include "linear_solvers/linear_solver.h" #include "FluidDynamicsApplication/custom_strategies/strategies/fs_strategy.h" @@ -153,44 +149,6 @@ void AddStrategies() ( "TrilinosBlockBuilderAndSolverPeriodic", init& >() ) ; - //******************************************************************************************** - class_ < SolverConfiguration, boost::noncopyable > - ( "SolverConfiguration", init< ModelPart&, unsigned int>() ) - .def( "GetActualizeRHSflag", &ConvergenceCriteria::GetActualizeRHSflag ) - .def( "GetActualizeRHSflag", &ConvergenceCriteria::GetActualizeRHSflag ) - ; - - //******************************************************************************************** - class_< FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >, boost::noncopyable > - ( "TrilinosFractionalStepStrategy", - init < ModelPart&, - SolverConfiguration&, - bool, - double, double, - int, int, - unsigned int, unsigned int, - bool - > () ) - .def( "Solve", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::Solve ) - .def( "SolveStep1", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::SolveStep1 ) - .def( "SolveStep2", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::SolveStep2 ) - .def( "SolveStep3", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::SolveStep3 ) - .def( "SolveStep4", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::SolveStep4 ) - .def( "ActOnLonelyNodes", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::ActOnLonelyNodes ) - .def( "Clear", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::Clear ) - .def( "FractionalVelocityIteration", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::FractionalVelocityIteration ) - .def( "ComputeReactions",&FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::ComputeReactions) - .def( "ConvergenceCheck", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::ConvergenceCheck ) - .def( "InitializeFractionalStep", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::InitializeFractionalStep ) - .def( "PredictVelocity", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::PredictVelocity ) - .def( "InitializeProjections", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::InitializeProjections ) - .def( "AssignInitialStepValues", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::AssignInitialStepValues ) - .def( "IterativeSolve", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::IterativeSolve ) - .def( "SavePressureIteration", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::SavePressureIteration ) - .def( "ApplyFractionalVelocityFixity", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::ApplyFractionalVelocityFixity ) - .def( "SetEchoLevel", &FractionalStepStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::SetEchoLevel ) - ; - //******************************************************************************************** class_< TrilinosConvectionDiffusionStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >, boost::noncopyable > ( "TrilinosConvectionDiffusionStrategy", init < Epetra_MpiComm&, ModelPart&, TrilinosLinearSolverType::Pointer, bool, int, int > () ) @@ -220,11 +178,9 @@ void AddStrategies() ; typedef FSStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType> TrilinosFSStrategy; - class_< TrilinosFSStrategy, boost::noncopyable > + class_< TrilinosFSStrategy, bases, boost::noncopyable > ("TrilinosFSStrategy",init< ModelPart&, SolverSettings< TrilinosSparseSpaceType,TrilinosLocalSpaceType, TrilinosLinearSolverType >&, bool >()) .def(init< ModelPart&, SolverSettings< TrilinosSparseSpaceType,TrilinosLocalSpaceType, TrilinosLinearSolverType >&, bool, const Kratos::Variable& >()) - .def("Solve",&TrilinosFSStrategy::Solve) - .def("Clear",&TrilinosFSStrategy::Clear) .def("CalculateReactions",&TrilinosFSStrategy::CalculateReactions) .def("AddIterationStep",&TrilinosFSStrategy::AddIterationStep) .def("ClearExtraIterationSteps",&TrilinosFSStrategy::ClearExtraIterationSteps) @@ -244,18 +200,16 @@ void AddStrategies() typedef TrilinosSpace TrilinosSparseSpaceType; typedef UblasSpace TrilinosLocalSpaceType; - class_< TrilinosLaplacianMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >, boost::noncopyable > + using TrilinosLaplacianMeshMovingStrategyType = TrilinosLaplacianMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >; + class_< TrilinosLaplacianMeshMovingStrategyType, bases, boost::noncopyable > ("TrilinosLaplacianMeshMovingStrategy", init() ) - .def("MoveNodes",&TrilinosLaplacianMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::MoveNodes) - .def("Solve", &TrilinosLaplacianMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::Solve ) - .def("SetEchoLevel", &TrilinosLaplacianMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::SetEchoLevel ) + .def("CalculateMeshVelocities", &TrilinosLaplacianMeshMovingStrategyType::CalculateMeshVelocities) ; - class_< TrilinosStructuralMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >, boost::noncopyable > + using TrilinosStructuralMeshMovingStrategyType = TrilinosStructuralMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >; + class_< TrilinosStructuralMeshMovingStrategyType, bases< TrilinosBaseSolvingStrategyType >, boost::noncopyable > ("TrilinosStructuralMeshMovingStrategy", init() ) - .def("MoveNodes",&TrilinosStructuralMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::MoveNodes) - .def("Solve", &TrilinosStructuralMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::Solve ) - .def("SetEchoLevel", &TrilinosStructuralMeshMovingStrategy< TrilinosSparseSpaceType, TrilinosLocalSpaceType, TrilinosLinearSolverType >::SetEchoLevel ) + .def("CalculateMeshVelocities", &TrilinosStructuralMeshMovingStrategyType::CalculateMeshVelocities) ; } diff --git a/applications/trilinos_application/custom_strategies/convergencecriterias/trilinos_displacement_criteria.h b/applications/trilinos_application/custom_strategies/convergencecriterias/trilinos_displacement_criteria.h index 1be7e0d672fe..4ff18821f58d 100644 --- a/applications/trilinos_application/custom_strategies/convergencecriterias/trilinos_displacement_criteria.h +++ b/applications/trilinos_application/custom_strategies/convergencecriterias/trilinos_displacement_criteria.h @@ -1,23 +1,23 @@ -// KRATOS _____ _ _ _ -// |_ _| __(_) (_)_ __ ___ ___ +// KRATOS _____ _ _ _ +// |_ _| __(_) (_)_ __ ___ ___ // | || '__| | | | '_ \ / _ \/ __| -// | || | | | | | | | | (_) \__ +// | || | | | | | | | | (_) \__ // |_||_| |_|_|_|_| |_|\___/|___/ APPLICATION // -// License: BSD License +// License: BSD License // Kratos default license: kratos/license.txt // // Main authors: Riccardo Rossi -// +// #if !defined(KRATOS_TRILINOS_DISPLACEMENT_CRITERIA ) #define KRATOS_TRILINOS_DISPLACEMENT_CRITERIA -// System includes +// System includes -// External includes +// External includes -// Project includes +// Project includes #include "includes/model_part.h" #include "includes/define.h" #include "solving_strategies/convergencecriterias/convergence_criteria.h" @@ -26,29 +26,29 @@ namespace Kratos { -///@name Kratos Globals +///@name Kratos Globals ///@{ -///@} -///@name Type Definitions +///@} +///@name Type Definitions ///@{ -///@} +///@} -///@name Enum's +///@name Enum's ///@{ -///@} -///@name Functions +///@} +///@name Functions ///@{ -///@} -///@name Kratos Classes +///@} +///@name Kratos Classes ///@{ // Short class definition @@ -78,7 +78,7 @@ template { public: - ///@name Type Definitions + ///@name Type Definitions ///@{ KRATOS_CLASS_POINTER_DEFINITION( TrilinosDisplacementCriteria ); @@ -95,18 +95,17 @@ class TrilinosDisplacementCriteria : public ConvergenceCriteria< TSparseSpace, T typedef typename BaseType::TSystemVectorType TSystemVectorType; - ///@} + ///@} ///@name Life Cycle - + ///@{ // * Constructor. - + TrilinosDisplacementCriteria( TDataType NewRatioTolerance, - TDataType AlwaysConvergedNorm, - Epetra_MpiComm& rComm) - : ConvergenceCriteria< TSparseSpace, TDenseSpace >(),mrComm(rComm) + TDataType AlwaysConvergedNorm) + : ConvergenceCriteria< TSparseSpace, TDenseSpace >() { mRatioTolerance = NewRatioTolerance; mAlwaysConvergedNorm = AlwaysConvergedNorm; @@ -115,18 +114,18 @@ class TrilinosDisplacementCriteria : public ConvergenceCriteria< TSparseSpace, T } // * Destructor. - + virtual ~TrilinosDisplacementCriteria() {} - ///@} + ///@} ///@name Operators - + ///@{ - // Criterias that need to be called after getting the solution + // Criterias that need to be called after getting the solution bool PostCriteria( - ModelPart& r_model_part, + ModelPart& rModelPart, DofsArrayType& rDofSet, const TSystemMatrixType& A, const TSystemVectorType& Dx, @@ -139,7 +138,7 @@ class TrilinosDisplacementCriteria : public ConvergenceCriteria< TSparseSpace, T TDataType ratio = 0.00; - mReferenceDispNorm = CalculateReferenceNorm(rDofSet); + mReferenceDispNorm = CalculateReferenceNorm(rDofSet, rModelPart); ratio = mFinalCorrectionNorm/mReferenceDispNorm; @@ -147,12 +146,12 @@ class TrilinosDisplacementCriteria : public ConvergenceCriteria< TSparseSpace, T double AbsoluteNorm = (mFinalCorrectionNorm/sqrt(aaa)); - if(mrComm.MyPID() == 0) //print performed only by the first processor + if(rModelPart.GetCommunicator().MyPID() == 0) //print performed only by the first processor std::cout << "DISPLACEMENT CRITERIA :: obtained tol = " << ratio << "; expected ratio = " << mRatioTolerance << "absolute tol = " << AbsoluteNorm << std::endl; if ( ratio <= mRatioTolerance || AbsoluteNorm(),mrComm(rComm) + TDataType PrsAbsTolerance) + : ConvergenceCriteria< TSparseSpace, TDenseSpace >() { mVelRatioTolerance = VelRatioTolerance; mVelAbsTolerance = VelAbsTolerance; @@ -196,13 +195,14 @@ class TrilinosUPCriteria : public ConvergenceCriteria< TSparseSpace, TDenseSpace double recvbuff[5]; // Get a reference to the MPI communicator (Epetra does not provide a direct interface to MPI_Reduce) - const MPI_Comm& rComm = mrComm.Comm(); + //Epetra_Comm epetra_comm = b.Comm(); + //const MPI_Comm& rComm = epetra_comm.Comm(); - MPI_Reduce(&sendbuff,&recvbuff,5,MPI_DOUBLE,MPI_SUM,0,rComm); + MPI_Reduce(&sendbuff,&recvbuff,5,MPI_DOUBLE,MPI_SUM,0,MPI_COMM_WORLD); int converged = 0; - if (mrComm.MyPID() == 0) + if (r_model_part.GetCommunicator().MyPID() == 0) { const double dimension = (r_model_part.ElementsBegin()->GetGeometry()).WorkingSpaceDimension(); const double vel_norm = sqrt( recvbuff[0] ); @@ -228,7 +228,7 @@ class TrilinosUPCriteria : public ConvergenceCriteria< TSparseSpace, TDenseSpace } // Broadcast convergence status from process 0 - MPI_Bcast(&converged,1,MPI_INT,0,rComm); + MPI_Bcast(&converged,1,MPI_INT,0,MPI_COMM_WORLD); return bool(converged); @@ -334,16 +334,13 @@ class TrilinosUPCriteria : public ConvergenceCriteria< TSparseSpace, TDenseSpace ///@} ///@name Member Variables ///@{ + TDataType mVelRatioTolerance; TDataType mVelAbsTolerance; TDataType mPrsRatioTolerance; TDataType mPrsAbsTolerance; - - Epetra_MpiComm& mrComm; - - ///@} ///@name Private Operations ///@{ diff --git a/applications/trilinos_application/custom_strategies/strategies/trilinos_laplacian_meshmoving_strategy.h b/applications/trilinos_application/custom_strategies/strategies/trilinos_laplacian_meshmoving_strategy.h index 5b71c94e0d0d..9749d740086c 100644 --- a/applications/trilinos_application/custom_strategies/strategies/trilinos_laplacian_meshmoving_strategy.h +++ b/applications/trilinos_application/custom_strategies/strategies/trilinos_laplacian_meshmoving_strategy.h @@ -168,9 +168,12 @@ class TrilinosLaplacianMeshMovingStrategy /** Destructor. */ + void Initialize() override + {} + //********************************************************************************* //********************************************************************************* - double Solve() + double Solve() override { KRATOS_TRY; @@ -267,7 +270,7 @@ class TrilinosLaplacianMeshMovingStrategy // Update FEM database CalculateMeshVelocities(); - BaseType::MoveMesh(); + MoveMesh(); // clearing the system if needed if (mreform_dof_at_every_step == true) @@ -333,12 +336,12 @@ class TrilinosLaplacianMeshMovingStrategy KRATOS_CATCH("") } - virtual void SetEchoLevel(int Level) + void SetEchoLevel(int Level) override { mstrategy->SetEchoLevel(Level); } - void MoveNodes() + void MoveMesh() override { const VariableComponentType& rMESH_DISPLACEMENT_X = KratosComponents::Get("MESH_DISPLACEMENT_X"); diff --git a/applications/trilinos_application/custom_strategies/strategies/trilinos_structural_meshmoving_strategy.h b/applications/trilinos_application/custom_strategies/strategies/trilinos_structural_meshmoving_strategy.h index 1689352e68a7..ae3be2882166 100644 --- a/applications/trilinos_application/custom_strategies/strategies/trilinos_structural_meshmoving_strategy.h +++ b/applications/trilinos_application/custom_strategies/strategies/trilinos_structural_meshmoving_strategy.h @@ -133,9 +133,12 @@ class TrilinosStructuralMeshMovingStrategy /** Destructor. */ + void Initialize() override + {} + //********************************************************************************* //********************************************************************************* - double Solve() + double Solve() override { KRATOS_TRY; @@ -154,7 +157,7 @@ class TrilinosStructuralMeshMovingStrategy // Update FEM database CalculateMeshVelocities(); - MoveNodes(); + MoveMesh(); // Clearing the system if needed if (mreform_dof_at_every_step == true) @@ -221,12 +224,12 @@ class TrilinosStructuralMeshMovingStrategy KRATOS_CATCH("") } - virtual void SetEchoLevel(int Level) + virtual void SetEchoLevel(int Level) override { mstrategy->SetEchoLevel(Level); } - void MoveNodes() + void MoveMesh() override { const VariableComponentType& rMESH_DISPLACEMENT_X = KratosComponents::Get("MESH_DISPLACEMENT_X"); diff --git a/applications/trilinos_application/python_scripts/trilinos_mesh_solver_base.py b/applications/trilinos_application/python_scripts/trilinos_mesh_solver_base.py new file mode 100644 index 000000000000..bf0c49116001 --- /dev/null +++ b/applications/trilinos_application/python_scripts/trilinos_mesh_solver_base.py @@ -0,0 +1,54 @@ +from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 +# importing the Kratos Library +import KratosMultiphysics +import KratosMultiphysics.ALEApplication as ALEApplication +import KratosMultiphysics.TrilinosApplication as TrilinosApplication +from KratosMultiphysics.mpi import * +KratosMultiphysics.CheckForPreviousImport() +import mesh_solver_base + + +def CreateSolver(model_part, custom_settings): + return TrilinosMeshSolverBase(model_part, custom_settings) + + +class TrilinosMeshSolverBase(mesh_solver_base.MeshSolverBase): + def __init__(self, model_part, custom_settings): + super(TrilinosMeshSolverBase, self).__init__(model_part, custom_settings) + mpi.world.barrier() + if mpi.rank == 0: + print("::[TrilinosMeshSolverBase]:: Construction finished") + + #### Public user interface functions #### + + def AddVariables(self): + super(TrilinosMeshSolverBase, self).AddVariables() + self.model_part.AddNodalSolutionStepVariable(KratosMultiphysics.PARTITION_INDEX) + mpi.world.barrier() + if mpi.rank == 0: + print("::[MeshSolverBase]:: Variables ADDED.") + + def AddDofs(self): + super(TrilinosMeshSolverBase, self).AddDofs() + mpi.world.barrier() + if mpi.rank == 0: + print("::[MeshSolverBase]:: DOFs ADDED.") + + #### Specific internal functions #### + + def get_communicator(self): + if not hasattr(self, '_communicator'): + self._communicator = TrilinosApplication.CreateCommunicator() + return self._communicator + + #### Private functions #### + + def _create_linear_solver(self): + import trilinos_linear_elastic_ml_solver + nit_max = 10000 + linear_tol = 1e-5 + linear_solver = trilinos_linear_elastic_ml_solver.MultilevelLinearSolver(linear_tol, nit_max) + return linear_solver + + def _create_mesh_motion_solver(self): + raise Exception("Mesh motion solver must be created by the derived class.") diff --git a/applications/trilinos_application/python_scripts/trilinos_mesh_solver_laplacian.py b/applications/trilinos_application/python_scripts/trilinos_mesh_solver_laplacian.py index d26ad3721caf..5cca705f6e16 100644 --- a/applications/trilinos_application/python_scripts/trilinos_mesh_solver_laplacian.py +++ b/applications/trilinos_application/python_scripts/trilinos_mesh_solver_laplacian.py @@ -1,64 +1,44 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.TrilinosApplication import * -from KratosMultiphysics.MetisApplication import * +import KratosMultiphysics +import KratosMultiphysics.ALEApplication as ALEApplication +import KratosMultiphysics.TrilinosApplication as TrilinosApplication from KratosMultiphysics.mpi import * -CheckForPreviousImport() +KratosMultiphysics.CheckForPreviousImport() +import trilinos_mesh_solver_base -def AddVariables(model_part): - model_part.AddNodalSolutionStepVariable(MESH_DISPLACEMENT) - model_part.AddNodalSolutionStepVariable(MESH_VELOCITY) - model_part.AddNodalSolutionStepVariable(MESH_REACTION) - model_part.AddNodalSolutionStepVariable(MESH_RHS) - model_part.AddNodalSolutionStepVariable(PARTITION_INDEX) - mpi.world.barrier() - if mpi.rank == 0: - print("variables for the mesh solver added correctly") +def CreateSolver(model_part, custom_settings): + return TrilinosMeshSolverComponentwise(model_part, custom_settings) -def AddDofs(model_part): - for node in model_part.Nodes: - # adding dofs - node.AddDof(MESH_DISPLACEMENT_X, MESH_REACTION_X) - node.AddDof(MESH_DISPLACEMENT_Y, MESH_REACTION_Y) - node.AddDof(MESH_DISPLACEMENT_Z, MESH_REACTION_Z) +class TrilinosMeshSolverComponentwise(trilinos_mesh_solver_base.TrilinosMeshSolverBase): + def __init__(self, model_part, custom_settings): + super(TrilinosMeshSolverComponentwise, self).__init__(model_part, custom_settings) + mpi.world.barrier() + if mpi.rank == 0: + print("::[TrilinosMeshSolverComponentwise]:: Construction finished") - mpi.world.barrier() - if mpi.rank == 0: - print("dofs for the mesh solver added correctly") + #### Private functions #### - -class TrilinosMeshSolverComponentwise: - - def __init__(self, model_part, domain_size, reform_dof_at_every_step): - - self.model_part = model_part - self.domain_size = domain_size - self.reform_dof_at_every_step = reform_dof_at_every_step - - #AddDofs(model_part) - - # assignation of parameters to be used - self.time_order = 1 - - # Create communicator - self.Comm = CreateCommunicator() - - # Define solver + def _create_linear_solver(self): import PressureMultiLevelSolver pressure_nit_max = 1000 pressure_linear_tol = 1e-6 - self.linear_solver = PressureMultiLevelSolver.MultilevelLinearSolver(pressure_linear_tol, pressure_nit_max) - - def Initialize(self): - self.solver = TrilinosLaplacianMeshMovingStrategy(self.Comm, self.model_part, self.linear_solver, self.domain_size, self.time_order, self.reform_dof_at_every_step) - (self.solver).SetEchoLevel(0) - print("finished moving the mesh") - - def Solve(self): - (self.solver).Solve() - - def MoveNodes(self): - (self.solver).MoveNodes() + linear_solver = PressureMultiLevelSolver.MultilevelLinearSolver(pressure_linear_tol, pressure_nit_max) + return linear_solver + + def _create_mesh_motion_solver(self): + domain_size = self.model_part.ProcessInfo[DOMAIN_SIZE] + linear_solver = self.get_linear_solver() + time_order = self.settings("time_order").GetInt() + reform_dofs_each_step = self.settings("reform_dofs_each_step").GetBool() + comm = self.get_communicator() + solver = TrilinosApplication.TrilinosLaplacianMeshMovingStrategy( + comm, + self.model_part, + linear_solver, + domain_size, + time_order, + reform_dof_at_every_step) + return solver diff --git a/applications/trilinos_application/python_scripts/trilinos_mesh_solver_structural_similarity.py b/applications/trilinos_application/python_scripts/trilinos_mesh_solver_structural_similarity.py index 267ac304cd0c..d761fc9d0d49 100644 --- a/applications/trilinos_application/python_scripts/trilinos_mesh_solver_structural_similarity.py +++ b/applications/trilinos_application/python_scripts/trilinos_mesh_solver_structural_similarity.py @@ -1,77 +1,35 @@ from __future__ import print_function, absolute_import, division #makes KratosMultiphysics backward compatible with python 2.6 and 2.7 # importing the Kratos Library -from KratosMultiphysics import * -from KratosMultiphysics.ALEApplication import * -from KratosMultiphysics.TrilinosApplication import * +import KratosMultiphysics +import KratosMultiphysics.ALEApplication as ALEApplication +import KratosMultiphysics.TrilinosApplication as TrilinosApplication from KratosMultiphysics.mpi import * -CheckForPreviousImport() +KratosMultiphysics.CheckForPreviousImport() +import trilinos_mesh_solver_base + def CreateSolver(model_part, custom_settings): return TrilinosMeshSolverStructuralSimilarity(model_part, custom_settings) -class TrilinosMeshSolverStructuralSimilarity: +class TrilinosMeshSolverStructuralSimilarity(trilinos_mesh_solver_base.TrilinosMeshSolverBase): def __init__(self, model_part, custom_settings): - - default_settings = Parameters(""" - { - "time_order" : 2, - "mesh_reform_dofs_each_step" : false - }""") - - custom_settings.ValidateAndAssignDefaults(default_settings) - - # set parameters - self.model_part = model_part - self.time_order = custom_settings["time_order"].GetInt() - self.mesh_reform_dofs_each_step = custom_settings["mesh_reform_dofs_each_step"].GetBool() - - # Create communicator - self.Comm = CreateCommunicator() - - # Define solver - import trilinos_linear_elastic_ml_solver - nit_max = 10000 - linear_tol = 1e-5 - self.linear_solver = trilinos_linear_elastic_ml_solver.MultilevelLinearSolver(linear_tol, nit_max) - if mpi.rank == 0: - print("Construction of TrilinosMeshSolverStructuralSimilarity finished") - - def AddVariables(self): - self.model_part.AddNodalSolutionStepVariable(MESH_DISPLACEMENT) - self.model_part.AddNodalSolutionStepVariable(MESH_VELOCITY) - self.model_part.AddNodalSolutionStepVariable(MESH_REACTION) - self.model_part.AddNodalSolutionStepVariable(MESH_RHS) - self.model_part.AddNodalSolutionStepVariable(PARTITION_INDEX) + super(TrilinosMeshSolverStructuralSimilarity, self).__init__(model_part, custom_settings) mpi.world.barrier() if mpi.rank == 0: - print("variables for the mesh solver added correctly") - - def AddDofs(self): - for node in self.model_part.Nodes: - node.AddDof(MESH_DISPLACEMENT_X, MESH_REACTION_X) - node.AddDof(MESH_DISPLACEMENT_Y, MESH_REACTION_Y) - node.AddDof(MESH_DISPLACEMENT_Z, MESH_REACTION_Z) - mpi.world.barrier() - if mpi.rank == 0: - print("dofs for the mesh solver added correctly") - - def Initialize(self): - # Initialize mesh model part - for node in self.model_part.Nodes: - zero = Vector(3) - zero[0] = 0.0 - zero[1] = 0.0 - zero[2] = 0.0 - node.SetSolutionStepValue(MESH_REACTION,0,zero) - node.SetSolutionStepValue(MESH_DISPLACEMENT,0,zero) - node.SetSolutionStepValue(MESH_RHS,0,zero) - - self.solver = TrilinosStructuralMeshMovingStrategy(self.Comm, self.model_part, self.linear_solver, self.time_order, self.mesh_reform_dofs_each_step) - (self.solver).SetEchoLevel(0) - - def Solve(self): - (self.solver).Solve() - - def MoveNodes(self): - (self.solver).MoveNodes() + print("::[TrilinosMeshSolverStructuralSimilarity]:: Construction finished") + + #### Private functions #### + + def _create_mesh_motion_solver(self): + linear_solver = self.get_linear_solver() + time_order = self.settings["time_order"].GetInt() + reform_dofs_each_step = self.settings["reform_dofs_each_step"].GetBool() + comm = self.get_communicator() + solver = TrilinosApplication.TrilinosStructuralMeshMovingStrategy( + comm, + self.model_part, + linear_solver, + time_order, + reform_dofs_each_step) + return solver diff --git a/embedded_python/krun_main.cpp b/embedded_python/krun_main.cpp index fbdb998bbf1f..200343b24489 100644 --- a/embedded_python/krun_main.cpp +++ b/embedded_python/krun_main.cpp @@ -1,10 +1,17 @@ #ifdef KRATOS_DEBUG -#include + #include #else -#undef _DEBUG -#include -#define _DEBUG + #ifdef _DEBUG + #define _DEBUG_DEFINED + #undef _DEBUG + #endif + #include + #ifdef _DEBUG_DEFINED + #undef _DEBUG_DEFINED + #define _DEBUG + #endif #endif + #include #if PY_MAJOR_VERSION >= 3 @@ -55,7 +62,6 @@ Py_NoSiteFlag = 1; Py_SetProgramName(wchar_argv[0]); - Py_Initialize(); PySys_SetArgv(argc-1, &wchar_argv[1] ); @@ -97,7 +103,6 @@ PyObject* sysPath = PySys_GetObject((char*)"path"); PyList_Insert(sysPath,0, PyString_FromString(".")); - PyList_Insert(sysPath,0, PyString_FromString("python27.zip")); PySys_SetArgv(argc-1,&argv[1]); char filename[1024]; @@ -120,4 +125,4 @@ return 0; } } -#endif +#endif diff --git a/external_libraries/mpi_python/CMakeLists.txt b/external_libraries/mpi_python/CMakeLists.txt index ccd35de7fbf4..1c6cbe2c9c32 100644 --- a/external_libraries/mpi_python/CMakeLists.txt +++ b/external_libraries/mpi_python/CMakeLists.txt @@ -10,7 +10,7 @@ add_definitions( -w ) ############################################################### add_library(mpipython SHARED ${MPI_PYTHON_SOURCES}) -target_link_libraries(mpipython ${Boost_PYTHON_LIBRARIES} ${PYTHON_LIBRARIES} ${MPI_LIBRARIES}) +target_link_libraries(mpipython ${Boost_LIBRARIES} ${PYTHON_LIBRARIES} ${MPI_LIBRARIES}) set_target_properties(mpipython PROPERTIES PREFIX "") diff --git a/kratos/CMakeLists.txt b/kratos/CMakeLists.txt index 5e6aee38599b..e411e61b45db 100644 --- a/kratos/CMakeLists.txt +++ b/kratos/CMakeLists.txt @@ -111,7 +111,7 @@ set( KRATOS_PYTHON_SOURCES ${CMAKE_CURRENT_SOURCE_DIR}/python/add_logger_to_python.cpp ${CMAKE_CURRENT_SOURCE_DIR}/python/add_model_to_python.cpp; ${CMAKE_CURRENT_SOURCE_DIR}/python/kratos_python.cpp - ${CMAKE_CURRENT_SOURCE_DIR}/sources/mpi_connectivity_preserve_modeler.cpp; + ${CMAKE_CURRENT_SOURCE_DIR}/sources/connectivity_preserve_modeler.cpp; # ${CMAKE_CURRENT_SOURCE_DIR}/processes/mdpa_reorder_consecutive_process.cpp; # ${CMAKE_CURRENT_SOURCE_DIR}/sources/kratos_exception.cpp; diff --git a/kratos/containers/data_value_container.h b/kratos/containers/data_value_container.h index df9a504be8eb..656f99a09cb4 100644 --- a/kratos/containers/data_value_container.h +++ b/kratos/containers/data_value_container.h @@ -186,6 +186,9 @@ class DataValueContainer template TDataType& GetValue(const Variable& rThisVariable) { +#ifdef KRATOS_DEBUG + KRATOS_ERROR_IF(rThisVariable.Key() == 0) << "attempting to do a GetValue for: " << rThisVariable << " the variable has key zero" << std::endl; +#endif typename ContainerType::iterator i; if ((i = std::find_if(mData.begin(), mData.end(), IndexCheck(rThisVariable.Key()))) != mData.end()) @@ -204,6 +207,10 @@ class DataValueContainer //TODO: make the variable of the constant version consistent with the one of the "classical" one template const TDataType& GetValue(const Variable& rThisVariable) const { +#ifdef KRATOS_DEBUG + KRATOS_ERROR_IF(rThisVariable.Key() == 0) << "attempting to do a GetValue for: " << rThisVariable << " the variable has key zero" << std::endl; +#endif + typename ContainerType::const_iterator i; if ((i = std::find_if(mData.begin(), mData.end(), IndexCheck(rThisVariable.Key()))) != mData.end()) @@ -229,6 +236,9 @@ class DataValueContainer template void SetValue(const Variable& rThisVariable, TDataType const& rValue) { +#ifdef KRATOS_DEBUG + KRATOS_ERROR_IF(rThisVariable.Key() == 0) << "attempting to do a SetValue for: " << rThisVariable << " the variable has key zero" << std::endl; +#endif typename ContainerType::iterator i; if ((i = std::find_if(mData.begin(), mData.end(), IndexCheck(rThisVariable.Key()))) != mData.end()) diff --git a/kratos/containers/fix_data_value_container.h b/kratos/containers/fix_data_value_container.h index 368443b972e8..f8abea3fb9f3 100644 --- a/kratos/containers/fix_data_value_container.h +++ b/kratos/containers/fix_data_value_container.h @@ -282,11 +282,7 @@ class FixDataValueContainer template TDataType& GetValue(const Variable& rThisVariable) { - if(!mpVariablesList->Has(rThisVariable)) - KRATOS_ERROR << "variable " << rThisVariable << " not found in the fixed_data_value_container"; -// mpVariablesList->Add(rThisVariable); - -// KRATOS_WATCH(rThisVariable) + KRATOS_ERROR_IF(rThisVariable.Key()==0) << "Trying to access unregistered (key = 0) variable " << rThisVariable.Name() << " in a call to FixDataValueContainer::GetValue." << std::endl; IndexType index = mpVariablesList->Index(rThisVariable); @@ -294,7 +290,6 @@ class FixDataValueContainer if((index >= mSize)||(mSize == 0)) Update(); -// KRATOS_WATCH(*(TDataType*)(mpData + index)) return *(TDataType*)(mpData + index); } @@ -302,12 +297,8 @@ class FixDataValueContainer { if(!mpVariablesList->Has(rThisVariable)) return rThisVariable.Zero(); - //std:: cout << "oh oh" << std::endl; - // KRATOS_WATCH(rThisVariable) - IndexType index = mpVariablesList->Index(rThisVariable); + IndexType index = mpVariablesList->Index(rThisVariable); -// KRATOS_WATCH(index) -// KRATOS_WATCH(mSize) if(index >= mSize) return rThisVariable.Zero(); @@ -318,26 +309,32 @@ class FixDataValueContainer //by Riccardo: variables are not added template TDataType& FastGetValue(const Variable& rThisVariable) { +#ifdef KRATOS_DEBUG + KRATOS_ERROR_IF(rThisVariable.Key()==0) << "Trying to access unregistered (key = 0) variable " << rThisVariable.Name() << " in a call to FixDataValueContainer::FastGetValue." << std::endl; + KRATOS_ERROR_IF(!mpVariablesList->Has(rThisVariable)) << "Trying to access " << rThisVariable.Name() << ", which is not added to this FixDataValueContainer." << std::endl; +#endif + IndexType index = mpVariablesList->Index(rThisVariable); + #ifdef KRATOS_DEBUG - //KRATOS_WATCH("attention printing FastGetValue"); - if(!mpVariablesList->Has(rThisVariable)) - KRATOS_ERROR << "variable " << rThisVariable << " not found in the fixed_data_value_container"; - if(index >= mSize) - KRATOS_ERROR << "variable " << rThisVariable << " an inconsistency of variable_list happend in the fixed_data_value_container"; + KRATOS_ERROR_IF(index >= mSize) << "An inconsistency in variable_list was encountered in a call to FixDataValueContainer::FastGetValue for variable " << rThisVariable << "." << std::endl; #endif + + return *(TDataType*)(mpData + index); } template const TDataType& FastGetValue(const Variable& rThisVariable) const { +#ifdef KRATOS_DEBUG + KRATOS_ERROR_IF(rThisVariable.Key()==0) << "Trying to access unregistered (key = 0) variable " << rThisVariable.Name() << " in a call to FixDataValueContainer::FastGetValue." << std::endl; + KRATOS_ERROR_IF(!mpVariablesList->Has(rThisVariable)) << "Trying to access " << rThisVariable.Name() << ", which is not added to this FixDataValueContainer." << std::endl; +#endif + IndexType index = mpVariablesList->Index(rThisVariable); + #ifdef KRATOS_DEBUG - //KRATOS_WATCH("attention printing FastGetValue"); - if(!mpVariablesList->Has(rThisVariable)) - KRATOS_ERROR << "variable " << rThisVariable << " not found in the fixed_data_value_container"; - if(index >= mSize) - KRATOS_ERROR << "variable " << rThisVariable << " an inconsistency of variable_list happend in the fixed_data_value_container"; + KRATOS_ERROR_IF(index >= mSize) << "An inconsistency in variable_list was encountered in a call to FixDataValueContainer::FastGetValue for variable " << rThisVariable << "." << std::endl; #endif return *(const TDataType*)(mpData + index); } @@ -473,12 +470,18 @@ class FixDataValueContainer template bool Has(const Variable& rThisVariable) const { +#ifdef KRATOS_DEBUG + KRATOS_ERROR_IF(rThisVariable.Key()==0) << "Trying to access unregistered (key = 0) variable " << rThisVariable.Name() << " in a call to FixDataValueContainer::Has." << std::endl; +#endif return mpVariablesList->Has(rThisVariable); } template bool Has(const VariableComponent& rThisVariable) const { - return mpVariablesList->Has(rThisVariable.GetSourceVariable()); +#ifdef KRATOS_DEBUG + KRATOS_ERROR_IF(rThisVariable.Key()==0) << "Trying to access unregistered (key = 0) component variable " << rThisVariable.Name() << " in a call to FixDataValueContainer::Has." << std::endl; +#endif + return mpVariablesList->Has(rThisVariable.GetSourceVariable()); } bool IsEmpty() diff --git a/kratos/containers/variable_data.h b/kratos/containers/variable_data.h index 4a6bf4b970de..8f8038b6fd65 100644 --- a/kratos/containers/variable_data.h +++ b/kratos/containers/variable_data.h @@ -109,11 +109,6 @@ class KRATOS_API(KRATOS_CORE) VariableData KeyType Key() const { - #ifdef KRATOS_DEBUG - if(mKey==0){ - KRATOS_ERROR << "The variable " << mName << " is not registered!!" << std::endl; - } - #endif return mKey; } diff --git a/kratos/geometries/geometry.h b/kratos/geometries/geometry.h index 388cd8354300..6205f96058e1 100644 --- a/kratos/geometries/geometry.h +++ b/kratos/geometries/geometry.h @@ -667,21 +667,69 @@ class Geometry : public PointerVector const SizeType points_number = this->size(); if ( points_number == 0 ) + { KRATOS_ERROR << "can not compute the ceneter of a geometry of zero points" << std::endl; // return PointType(); + } Point<3> result = ( *this )[0]; for ( IndexType i = 1 ; i < points_number ; i++ ) + { result.Coordinates() += ( *this )[i]; + } - double temp = 1.0 / double( points_number ); + const double temp = 1.0 / double( points_number ); result.Coordinates() *= temp; return result; } + + /** + * It computes the unit normal of the geometry, if possible + * @return The normal of the geometry + */ + virtual array_1d Normal(const CoordinatesArrayType& rPointLocalCoordinates) + { + const unsigned int local_space_dimension = this->LocalSpaceDimension(); + const unsigned int dimension = this->WorkingSpaceDimension(); + + if (dimension == local_space_dimension) + { + KRATOS_ERROR << "Remember the normal can be computed just in geometries with a local dimension: "<< this->LocalSpaceDimension() << "smaller than the spatial dimension: " << this->WorkingSpaceDimension() << std::endl; + } + + // We define the normal and tangents + array_1d tangent_xi(0.0); + array_1d tangent_eta(0.0); + + Matrix j_node = ZeroMatrix( dimension, local_space_dimension ); + this->Jacobian( j_node, rPointLocalCoordinates); + + // Using the Jacobian tangent directions + if (dimension == 2) + { + tangent_eta[2] = 1.0; + for (unsigned int i_dim = 0; i_dim < dimension; i_dim++) + { + tangent_xi[i_dim] = j_node(i_dim, 0); + } + } + else + { + for (unsigned int i_dim = 0; i_dim < dimension; i_dim++) + { + tangent_xi[i_dim] = j_node(i_dim, 0); + tangent_eta[i_dim] = j_node(i_dim, 1); + } + } + array_1d normal; + MathUtils::CrossProduct(normal, tangent_xi, tangent_eta); + return normal/norm_2(normal); + } + /** Calculates the quality of the geometry according to a given criteria. * * Calculates the quality of the geometry according to a given criteria. In General @@ -815,10 +863,15 @@ class Geometry : public PointerVector } /** - * Returns the local coordinates of a given arbitrary point - */ - virtual CoordinatesArrayType& PointLocalCoordinates( CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ + virtual CoordinatesArrayType& PointLocalCoordinates( + CoordinatesArrayType& rResult, + const CoordinatesArrayType& rPoint + ) { Matrix J = ZeroMatrix( LocalSpaceDimension(), LocalSpaceDimension() ); @@ -829,11 +882,11 @@ class Geometry : public PointerVector CoordinatesArrayType CurrentGlobalCoords( ZeroVector( 3 ) ); //Newton iteration: - double tol = 1.0e-8; + const double tol = 1.0e-8; - int maxiter = 1000; + unsigned int maxiter = 1000; - for ( int k = 0; k < maxiter; k++ ) + for ( unsigned int k = 0; k < maxiter; k++ ) { CurrentGlobalCoords = ZeroVector( 3 ); GlobalCoordinates( CurrentGlobalCoords, rResult ); @@ -859,15 +912,23 @@ class Geometry : public PointerVector } /** - * Returns whether given arbitrary point is inside the Geometry and the respective - * local point for the given global point - */ - virtual bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) { KRATOS_ERROR << "Calling base class IsInside method instead of derived class one. Please check the definition of derived class. " << *this << std::endl; return false; } - + ///@} ///@name Inquiry ///@{ diff --git a/kratos/geometries/hexahedra_3d_20.h b/kratos/geometries/hexahedra_3d_20.h index 316d13ba33cf..028805105b5f 100644 --- a/kratos/geometries/hexahedra_3d_20.h +++ b/kratos/geometries/hexahedra_3d_20.h @@ -459,18 +459,32 @@ template class Hexahedra3D20 : public Geometry return Volume(); } - /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if ( fabs( rResult[0] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[1] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[2] ) <= (1.0 + Tolerance) ) + if ( std::abs( rResult[0] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[1] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[2] ) <= (1.0 + Tolerance) ) + { return true; + } + } + } return false; } diff --git a/kratos/geometries/hexahedra_3d_27.h b/kratos/geometries/hexahedra_3d_27.h index 39450201be11..da8ca9879650 100644 --- a/kratos/geometries/hexahedra_3d_27.h +++ b/kratos/geometries/hexahedra_3d_27.h @@ -484,26 +484,39 @@ template class Hexahedra3D27 : public Geometry } /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if ( fabs( rResult[0] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[1] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[2] ) <= (1.0 + Tolerance) ) + if ( std::abs( rResult[0] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[1] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[2] ) <= (1.0 + Tolerance) ) + { return true; + } + } + } return false; } - /** * Jacobian */ - /** This method gives you number of all edges of this geometry. @return SizeType containes number of this geometry edges. diff --git a/kratos/geometries/hexahedra_3d_8.h b/kratos/geometries/hexahedra_3d_8.h index 118650ce28cd..447f975e6376 100644 --- a/kratos/geometries/hexahedra_3d_8.h +++ b/kratos/geometries/hexahedra_3d_8.h @@ -25,7 +25,6 @@ #include "geometries/quadrilateral_3d_4.h" #include "integration/hexahedron_gauss_legendre_integration_points.h" - namespace Kratos { /** @@ -454,16 +453,31 @@ template class Hexahedra3D8 : public Geometry } /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if ( fabs( rResult[0] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[1] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[2] ) <= (1.0 + Tolerance) ) + if ( std::abs( rResult[0] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[1] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[2] ) <= (1.0 + Tolerance) ) + { return true; + } + } + } return false; } diff --git a/kratos/geometries/hexahedra_interface_3d_8.h b/kratos/geometries/hexahedra_interface_3d_8.h index ab0bbb8d1e4b..e083cd8d2652 100644 --- a/kratos/geometries/hexahedra_interface_3d_8.h +++ b/kratos/geometries/hexahedra_interface_3d_8.h @@ -28,7 +28,7 @@ namespace Kratos { /** * An eight node hexahedra interface geometry. The shape functions are the same as for the - * hexahedra_3d_8 element, but the jacobian is computed as in the quadrilateral_3d_4 element to + * hexahedra_3d_8 element, but the jacobian is computed as in the quadrilateral_3d_4 element to * to avoid having detJ = 0. Default integration method is Lobatto. */ @@ -166,7 +166,7 @@ template class HexahedraInterface3D8 : public Geometry vx; vx.clear(); noalias(vx) += - Point1 - Point5; @@ -320,13 +320,13 @@ template class HexahedraInterface3D8 : public Geometry::Norm3(vx); double ly = MathUtils::Norm3(vy); double lz = MathUtils::Norm3(vz); - + if(lz < lx) { if(lz < ly) { // lz < lx && lz < ly - + this->Points().push_back( pPoint1 ); this->Points().push_back( pPoint2 ); this->Points().push_back( pPoint3 ); @@ -339,7 +339,7 @@ template class HexahedraInterface3D8 : public GeometryPoints().push_back( pPoint1 ); this->Points().push_back( pPoint4 ); this->Points().push_back( pPoint8 ); @@ -353,7 +353,7 @@ template class HexahedraInterface3D8 : public GeometryPoints().push_back( pPoint1 ); this->Points().push_back( pPoint4 ); this->Points().push_back( pPoint8 ); @@ -366,7 +366,7 @@ template class HexahedraInterface3D8 : public GeometryPoints().push_back( pPoint1 ); this->Points().push_back( pPoint5 ); this->Points().push_back( pPoint6 ); @@ -419,12 +419,12 @@ template class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry >::Pointer Clone() const + + Geometry< Point<3> >::Pointer Clone() const override { Geometry< Point<3> >::PointsArrayType NewPoints; @@ -496,7 +496,7 @@ template class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry p2 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 5 )); array_1d p3 = 0.5 * (BaseType::GetPoint( 2 ) + BaseType::GetPoint( 6 )); array_1d p4 = 0.5 * (BaseType::GetPoint( 3 ) + BaseType::GetPoint( 7 )); - + //const TPointType& p1 = this->Points()[0]; //const TPointType& p2 = this->Points()[1]; //const TPointType& p3 = this->Points()[2]; @@ -593,14 +593,14 @@ template class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry::epsilon() ) + bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if ( fabs( rResult[0] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[1] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[2] ) <= (1.0 + Tolerance) ) + if ( std::abs( rResult[0] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[1] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[2] ) <= (1.0 + Tolerance) ) + { return true; + } + } + } return false; } - virtual CoordinatesArrayType& PointLocalCoordinates( CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) + /** + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ + CoordinatesArrayType& PointLocalCoordinates( + CoordinatesArrayType& rResult, + const CoordinatesArrayType& rPoint + ) override { boost::numeric::ublas::bounded_matrix X; boost::numeric::ublas::bounded_matrix DN; @@ -790,9 +813,9 @@ template class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public GeometryIntegrationPointsNumber( ThisMethod ) ) rResult.resize( this->IntegrationPointsNumber( ThisMethod ), false ); @@ -944,11 +967,11 @@ template class HexahedraInterface3D8 : public Geometry Tangent0; array_1d Tangent1; array_1d Normal; - + for ( unsigned int pnt = 0; pnt < this->IntegrationPointsNumber( ThisMethod ); pnt++ ) { this->Jacobian( J, pnt, ThisMethod); - + Tangent0[0] = J(0,0); Tangent0[1] = J(1,0); Tangent0[2] = J(2,0); @@ -956,9 +979,9 @@ template class HexahedraInterface3D8 : public Geometry::CrossProduct(Normal, Tangent0, Tangent1); - + rResult[pnt] = MathUtils::Norm3(Normal); } return rResult; @@ -986,12 +1009,12 @@ template class HexahedraInterface3D8 : public GeometryJacobian( J, IntegrationPointIndex, ThisMethod); - + array_1d Tangent0; array_1d Tangent1; array_1d Normal; @@ -1003,9 +1026,9 @@ template class HexahedraInterface3D8 : public Geometry::CrossProduct(Normal, Tangent0, Tangent1); - + return MathUtils::Norm3(Normal); } @@ -1028,8 +1051,8 @@ template class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry::Pointer EdgePointerType; @@ -1156,7 +1179,7 @@ template class HexahedraInterface3D8 : public Geometry::Pointer FacePointerType; @@ -1207,8 +1230,8 @@ template class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry class HexahedraInterface3D8 : public Geometry::msGeometryData( }// namespace Kratos. -#endif // KRATOS_HEXAHEDRA_INTERFACE_3D_8_H_INCLUDED defined - +#endif // KRATOS_HEXAHEDRA_INTERFACE_3D_8_H_INCLUDED defined diff --git a/kratos/geometries/line_2d_2.h b/kratos/geometries/line_2d_2.h index edd60ada1187..443dab5e1e71 100644 --- a/kratos/geometries/line_2d_2.h +++ b/kratos/geometries/line_2d_2.h @@ -791,6 +791,31 @@ class Line2D2 : public Geometry return( rResult ); } + /** + * It computes the unit normal of the geometry, if possible + * @return The normal of the geometry + */ + array_1d Normal(const CoordinatesArrayType& rPointLocalCoordinates) override + { + // We define the normal + array_1d normal; + + // We get the local points + const TPointType& first_point = BaseType::GetPoint(0); + const TPointType& second_point = BaseType::GetPoint(1); + + // We compute the normal + normal[0] = second_point[1] - first_point[1]; + normal[1] = first_point[0] - second_point[0]; + normal[2] = 0.0; + + // We normalize + const double norm = std::sqrt(normal[0] * normal[0] + normal[1] * normal[1]); + normal /= norm; + + return normal; + } + /** * returns the local coordinates of all nodes of the current geometry * @param rResult a Matrix object that will be overwritten by the result @@ -830,30 +855,39 @@ class Line2D2 : public Geometry } /** - * Returns whether given arbitrary point is inside the Geometry and the respective + * Returns whether given arbitrary point is inside the Geometry and the respective * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { PointLocalCoordinates( rResult, rPoint ); - if ( (rResult[0] >= (-1.0 - Tolerance)) && (rResult[0] <= (1.0 + Tolerance)) ) + if ( std::abs( rResult[0] ) <= (1.0 + Tolerance) ) { return true; } - else - { - return false; - } + + return false; } - - + /** - * Returns the local coordinates of a given arbitrary point - */ - CoordinatesArrayType& PointLocalCoordinates( + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ + virtual CoordinatesArrayType& PointLocalCoordinates( CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) override + const CoordinatesArrayType& rPoint + ) override { rResult.clear(); @@ -861,54 +895,28 @@ class Line2D2 : public Geometry const TPointType& SecondPoint = BaseType::GetPoint(1); // Project point - const double tol = 1e-14; // Tolerance - - // Normal - array_1d Normal = ZeroVector(2); - Normal[0] = SecondPoint[1] - FirstPoint[1]; - Normal[1] = FirstPoint[0] - SecondPoint[0]; - const double norm = std::sqrt(Normal[0] * Normal[0] + Normal[1] * Normal[1]); - Normal /= norm; - - // Vector point and distance - array_1d VectorPoint = ZeroVector(2); - VectorPoint[0] = rPoint[0] - FirstPoint[0]; - VectorPoint[1] = rPoint[1] - FirstPoint[1]; - const double dist_proy = VectorPoint[0] * Normal[0] + VectorPoint[1] * Normal[1]; - -// KRATOS_WATCH(rPoint); -// KRATOS_WATCH(Point_projected); -// KRATOS_WATCH(dist_proy); - - if (dist_proy < tol) - { - const double L = Length(); + const double Tolerance = 1e-14; // Tolerance - const double l1 = std::sqrt((rPoint[0] - FirstPoint[0]) * (rPoint[0] - FirstPoint[0]) - + (rPoint[1] - FirstPoint[1]) * (rPoint[1] - FirstPoint[1])); + const double Length = std::sqrt((SecondPoint[0] - FirstPoint[0]) * (SecondPoint[0] - FirstPoint[0]) + + (SecondPoint[1] - FirstPoint[1]) * (SecondPoint[1] - FirstPoint[1])); - const double l2 = std::sqrt((rPoint[0] - SecondPoint[0]) * (rPoint[0] - SecondPoint[0]) - + (rPoint[1] - SecondPoint[1]) * (rPoint[1] - SecondPoint[1])); + const double Length1 = std::sqrt((rPoint[0] - FirstPoint[0]) * (rPoint[0] - FirstPoint[0]) + + (rPoint[1] - FirstPoint[1]) * (rPoint[1] - FirstPoint[1])); -// std::cout << "L: " << L << " l1: " << l1 << " l2: " << l2 << std::endl; - - if (l1 <= (L + tol) && l2 <= (L + tol)) - { - rResult[0] = 2.0 * l1/(L + tol) - 1.0; - } - else if (l1 > (L + tol)) - { - rResult[0] = 2.0 * l1/(L + tol) - 1.0; // NOTE: The same value as before, but it will be > than 1 - } - else if (l2 > (L + tol)) - { - rResult[0] = 1.0 - 2.0 * l2/(L + tol); - } - else - { - rResult[0] = 2.0; // Out of the line!!! TODO: Check if this value gives problems - } + const double Length2 = std::sqrt((rPoint[0] - SecondPoint[0]) * (rPoint[0] - SecondPoint[0]) + + (rPoint[1] - SecondPoint[1]) * (rPoint[1] - SecondPoint[1])); + if (Length1 <= (Length + Tolerance) && Length2 <= (Length + Tolerance)) + { + rResult[0] = 2.0 * Length1/(Length + Tolerance) - 1.0; + } + else if (Length1 > (Length + Tolerance)) + { + rResult[0] = 2.0 * Length1/(Length + Tolerance) - 1.0; // NOTE: The same value as before, but it will be > than 1 + } + else if (Length2 > (Length + Tolerance)) + { + rResult[0] = 1.0 - 2.0 * Length2/(Length + Tolerance); } else { @@ -917,7 +925,7 @@ class Line2D2 : public Geometry return( rResult ); } - + ///@} ///@name Friends ///@{ diff --git a/kratos/geometries/line_2d_3.h b/kratos/geometries/line_2d_3.h index 99c70f339d0f..99ad9150167a 100644 --- a/kratos/geometries/line_2d_3.h +++ b/kratos/geometries/line_2d_3.h @@ -352,18 +352,27 @@ class Line2D3 : public Geometry return sqrt( length ); } - - - + /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if ( fabs( rResult[0] ) <= (1.0 + Tolerance) ) + if ( std::abs( rResult[0] ) <= (1.0 + Tolerance) ) + { return true; + } return false; } @@ -927,7 +936,9 @@ class Line2D3 : public Geometry IntegrationPointsContainerType integration_points = {{ Quadrature >::GenerateIntegrationPoints(), Quadrature >::GenerateIntegrationPoints(), - Quadrature >::GenerateIntegrationPoints() + Quadrature >::GenerateIntegrationPoints(), + Quadrature >::GenerateIntegrationPoints(), + Quadrature >::GenerateIntegrationPoints() } }; return integration_points; @@ -938,7 +949,9 @@ class Line2D3 : public Geometry ShapeFunctionsValuesContainerType shape_functions_values = {{ Line2D3::CalculateShapeFunctionsIntegrationPointsValues( GeometryData::GI_GAUSS_1 ), Line2D3::CalculateShapeFunctionsIntegrationPointsValues( GeometryData::GI_GAUSS_2 ), - Line2D3::CalculateShapeFunctionsIntegrationPointsValues( GeometryData::GI_GAUSS_3 ) + Line2D3::CalculateShapeFunctionsIntegrationPointsValues( GeometryData::GI_GAUSS_3 ), + Line2D3::CalculateShapeFunctionsIntegrationPointsValues( GeometryData::GI_GAUSS_4 ), + Line2D3::CalculateShapeFunctionsIntegrationPointsValues( GeometryData::GI_GAUSS_5 ) } }; return shape_functions_values; @@ -949,7 +962,9 @@ class Line2D3 : public Geometry ShapeFunctionsLocalGradientsContainerType shape_functions_local_gradients = {{ Line2D3::CalculateShapeFunctionsIntegrationPointsLocalGradients( GeometryData::GI_GAUSS_1 ), Line2D3::CalculateShapeFunctionsIntegrationPointsLocalGradients( GeometryData::GI_GAUSS_2 ), - Line2D3::CalculateShapeFunctionsIntegrationPointsLocalGradients( GeometryData::GI_GAUSS_3 ) + Line2D3::CalculateShapeFunctionsIntegrationPointsLocalGradients( GeometryData::GI_GAUSS_3 ), + Line2D3::CalculateShapeFunctionsIntegrationPointsLocalGradients( GeometryData::GI_GAUSS_4 ), + Line2D3::CalculateShapeFunctionsIntegrationPointsLocalGradients( GeometryData::GI_GAUSS_5 ) } }; return shape_functions_local_gradients; diff --git a/kratos/geometries/line_3d_3.h b/kratos/geometries/line_3d_3.h index 25be6e952992..9bfca89f34b7 100644 --- a/kratos/geometries/line_3d_3.h +++ b/kratos/geometries/line_3d_3.h @@ -356,9 +356,18 @@ class Line3D3 : public Geometry } /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); diff --git a/kratos/geometries/prism_3d_15.h b/kratos/geometries/prism_3d_15.h index 9761c6f73d00..6077f3b67892 100644 --- a/kratos/geometries/prism_3d_15.h +++ b/kratos/geometries/prism_3d_15.h @@ -510,9 +510,18 @@ template class Prism3D15 : public Geometry } /** - * Returns whether given arbitrary point is inside the Geometry - */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); diff --git a/kratos/geometries/prism_3d_6.h b/kratos/geometries/prism_3d_6.h index f84588d213b1..f30a8e81a6e0 100644 --- a/kratos/geometries/prism_3d_6.h +++ b/kratos/geometries/prism_3d_6.h @@ -456,9 +456,18 @@ template class Prism3D6 : public Geometry } /** - * Returns whether given arbitrary point is inside the Geometry - */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); diff --git a/kratos/geometries/prism_interface_3d_6.h b/kratos/geometries/prism_interface_3d_6.h index bbdebd620124..b6440da03698 100644 --- a/kratos/geometries/prism_interface_3d_6.h +++ b/kratos/geometries/prism_interface_3d_6.h @@ -22,7 +22,6 @@ #include "geometries/quadrilateral_3d_4.h" #include "integration/prism_gauss_lobatto_integration_points.h" - namespace Kratos { ///@name Kratos Globals @@ -46,7 +45,7 @@ namespace Kratos /** * A six node prism interface geometry. The shape functions are the same as for the - * prism_3d_6 element, but the jacobian is computed as in the triangle_3d_3 element to + * prism_3d_6 element, but the jacobian is computed as in the triangle_3d_3 element to * to avoid having detJ = 0. Default integration method is Lobatto. */ @@ -264,12 +263,12 @@ template class PrismInterface3D6 */ virtual ~PrismInterface3D6() {} - GeometryData::KratosGeometryFamily GetGeometryFamily() + GeometryData::KratosGeometryFamily GetGeometryFamily() override { return GeometryData::Kratos_Prism; } - GeometryData::KratosGeometryType GetGeometryType() + GeometryData::KratosGeometryType GetGeometryType() override { return GeometryData::Kratos_Prism3D6; } @@ -317,12 +316,12 @@ template class PrismInterface3D6 ///@name Operations ///@{ - typename BaseType::Pointer Create( PointsArrayType const& ThisPoints ) const + typename BaseType::Pointer Create( PointsArrayType const& ThisPoints ) const override { return typename BaseType::Pointer( new PrismInterface3D6( ThisPoints ) ); } - - virtual Geometry< Point<3> >::Pointer Clone() const + + Geometry< Point<3> >::Pointer Clone() const override { Geometry< Point<3> >::PointsArrayType NewPoints; @@ -344,7 +343,7 @@ template class PrismInterface3D6 * @param rResult a Matrix object that will be overwritten by the result * @return the local coordinates of all nodes */ - virtual Matrix& PointsLocalCoordinates( Matrix& rResult ) const + Matrix& PointsLocalCoordinates( Matrix& rResult ) const override { if ( rResult.size1() != 6 || rResult.size2() != 3 ) rResult.resize( 6, 3, false ); @@ -377,7 +376,7 @@ template class PrismInterface3D6 } //lumping factors for the calculation of the lumped mass matrix - virtual Vector& LumpingFactors( Vector& rResult ) const + Vector& LumpingFactors( Vector& rResult ) const override { rResult.resize( 6, false ); std::fill( rResult.begin(), rResult.end(), 1.00 / 6.00 ); @@ -407,7 +406,7 @@ template class PrismInterface3D6 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - virtual double Length() const + double Length() const override { return std::sqrt(2.0*Area()); } @@ -427,12 +426,12 @@ template class PrismInterface3D6 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - virtual double Area() const + double Area() const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 4 )); array_1d p2 = 0.5 * (BaseType::GetPoint( 2 ) + BaseType::GetPoint( 5 )); - + //heron formula Vector side_a = ( p0 - p1 ); double a = MathUtils::Norm3( side_a ); @@ -444,7 +443,7 @@ template class PrismInterface3D6 return( sqrt( s*( s - a )*( s - b )*( s - c ) ) ); } - virtual double Volume() const + double Volume() const override { return Area(); } @@ -463,15 +462,24 @@ template class PrismInterface3D6 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - virtual double DomainSize() const + double DomainSize() const override { return Area(); } /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - virtual bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) + bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); @@ -485,8 +493,16 @@ template class PrismInterface3D6 return false; } - virtual CoordinatesArrayType& PointLocalCoordinates( CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) + /** + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ + CoordinatesArrayType& PointLocalCoordinates( + CoordinatesArrayType& rResult, + const CoordinatesArrayType& rPoint + ) override { boost::numeric::ublas::bounded_matrix X; boost::numeric::ublas::bounded_matrix DN; @@ -578,14 +594,14 @@ template class PrismInterface3D6 * @see DeterminantOfJacobian * @see InverseOfJacobian */ - virtual Matrix& Jacobian( Matrix& rResult, - IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod ) const + Matrix& Jacobian( Matrix& rResult, + IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 4 )); array_1d p2 = 0.5 * (BaseType::GetPoint( 2 ) + BaseType::GetPoint( 5 )); - + rResult.resize( 3, 2, false ); rResult( 0, 0 ) = -( p0[0] ) + ( p1[0] ); //on the Gauss points (J is constant at each element) rResult( 1, 0 ) = -( p0[1] ) + ( p1[1] ); @@ -616,23 +632,23 @@ template class PrismInterface3D6 @see DeterminantOfJacobian @see InverseOfJacobian */ - virtual Matrix& Jacobian( Matrix& rResult, - IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod, - Matrix& DeltaPosition ) const + Matrix& Jacobian( Matrix& rResult, + IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod, + Matrix& DeltaPosition ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 4 )); array_1d p2 = 0.5 * (BaseType::GetPoint( 2 ) + BaseType::GetPoint( 5 )); - + Matrix deltaPosMid(3, 3); for(unsigned int i = 0; i < 3; i++) for(unsigned int j = 0; j < 3; j++) deltaPosMid(i, j) = 0.5*( DeltaPosition(i, j) + DeltaPosition(i+3, j) ); - + if(rResult.size1() != 3 || rResult.size2() != 2) rResult.resize(3, 2, false); - + rResult( 0, 0 ) = -( p0[0] - deltaPosMid(0,0) ) + ( p1[0] - deltaPosMid(1,0) ); //on the Gauss points (J is constant at each element) rResult( 1, 0 ) = -( p0[1] - deltaPosMid(0,1) ) + ( p1[1] - deltaPosMid(1,1) ); rResult( 2, 0 ) = -( p0[2] - deltaPosMid(0,2) ) + ( p1[2] - deltaPosMid(1,2) ); @@ -642,7 +658,7 @@ template class PrismInterface3D6 return rResult; } - + /** * TODO: implemented but not yet tested */ @@ -658,12 +674,12 @@ template class PrismInterface3D6 * @see DeterminantOfJacobian * @see InverseOfJacobian */ - virtual Matrix& Jacobian( Matrix& rResult, const CoordinatesArrayType& rPoint ) const + Matrix& Jacobian( Matrix& rResult, const CoordinatesArrayType& rPoint ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 4 )); array_1d p2 = 0.5 * (BaseType::GetPoint( 2 ) + BaseType::GetPoint( 5 )); - + rResult.resize( 3, 2 , false); rResult( 0, 0 ) = -( p0[0] ) + ( p1[0] ); //on the Gauss points (J is constant at each element) rResult( 1, 0 ) = -( p0[1] ) + ( p1[1] ); @@ -689,25 +705,25 @@ template class PrismInterface3D6 * @see Jacobian * @see InverseOfJacobian */ - virtual Vector& DeterminantOfJacobian( Vector& rResult, - IntegrationMethod ThisMethod ) const + Vector& DeterminantOfJacobian( Vector& rResult, + IntegrationMethod ThisMethod ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 4 )); array_1d p2 = 0.5 * (BaseType::GetPoint( 2 ) + BaseType::GetPoint( 5 )); - + array_1d Tangent1( p1 - p0 ); array_1d Tangent2( p2 - p0 ); - + array_1d Normal; MathUtils::CrossProduct( Normal, Tangent1, Tangent2); - + double detJ = norm_2(Normal); //for all integration points if ( rResult.size() != this->IntegrationPointsNumber( ThisMethod ) ) rResult.resize( this->IntegrationPointsNumber( ThisMethod ), false ); - + for ( unsigned int pnt = 0; pnt < this->IntegrationPointsNumber( ThisMethod ); pnt++ ) rResult[pnt] = detJ; @@ -736,19 +752,19 @@ template class PrismInterface3D6 * @see Jacobian * @see InverseOfJacobian */ - virtual double DeterminantOfJacobian( IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod ) const + double DeterminantOfJacobian( IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 4 )); array_1d p2 = 0.5 * (BaseType::GetPoint( 2 ) + BaseType::GetPoint( 5 )); - + array_1d Tangent1( p1 - p0 ); array_1d Tangent2( p2 - p0 ); - + array_1d Normal; MathUtils::CrossProduct( Normal, Tangent1, Tangent2); - + return norm_2(Normal); } @@ -777,18 +793,18 @@ template class PrismInterface3D6 * point in space this needs to be reviewed * (comment by janosch) */ - virtual double DeterminantOfJacobian( const CoordinatesArrayType& rPoint ) const + double DeterminantOfJacobian( const CoordinatesArrayType& rPoint ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 4 )); array_1d p2 = 0.5 * (BaseType::GetPoint( 2 ) + BaseType::GetPoint( 5 )); - + array_1d Tangent1( p1 - p0 ); array_1d Tangent2( p2 - p0 ); - + array_1d Normal; MathUtils::CrossProduct( Normal, Tangent1, Tangent2); - + return norm_2(Normal); } @@ -813,8 +829,8 @@ template class PrismInterface3D6 * * KLUDGE: works only with explicitly generated Matrix object */ - virtual JacobiansType& InverseOfJacobian( JacobiansType& rResult, - IntegrationMethod ThisMethod ) const + JacobiansType& InverseOfJacobian( JacobiansType& rResult, + IntegrationMethod ThisMethod ) const override { KRATOS_ERROR << "Jacobian is not square" << std::endl;; return rResult; @@ -843,9 +859,9 @@ template class PrismInterface3D6 * * KLUDGE: works only with explicitly generated Matrix object */ - virtual Matrix& InverseOfJacobian( Matrix& rResult, - IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod ) const + Matrix& InverseOfJacobian( Matrix& rResult, + IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod ) const override { KRATOS_ERROR << "Jacobian is not square" << std::endl; return rResult; @@ -867,8 +883,8 @@ template class PrismInterface3D6 * * KLUDGE: works only with explicitly generated Matrix object */ - virtual Matrix& InverseOfJacobian( Matrix& rResult, - const CoordinatesArrayType& rPoint ) const + Matrix& InverseOfJacobian( Matrix& rResult, + const CoordinatesArrayType& rPoint ) const override { KRATOS_ERROR << "Jacobian is not square" << std::endl; return rResult; @@ -884,16 +900,16 @@ template class PrismInterface3D6 @see Edges() @see Edge() */ - virtual SizeType EdgesNumber() const + SizeType EdgesNumber() const override { return 9; } - virtual SizeType FacesNumber() const + SizeType FacesNumber() const override { return 5; } - + /** This method gives you all edges of this geometry. This method will gives you all the edges with one dimension less than this geometry. for example a triangle would return @@ -905,7 +921,7 @@ template class PrismInterface3D6 @see EdgesNumber() @see Edge() */ - virtual GeometriesArrayType Edges( void ) + GeometriesArrayType Edges( void ) override { GeometriesArrayType edges = GeometriesArrayType(); typedef typename Geometry::Pointer EdgePointerType; @@ -939,7 +955,7 @@ template class PrismInterface3D6 return edges; } - virtual GeometriesArrayType Faces( void ) + GeometriesArrayType Faces( void ) override { GeometriesArrayType faces = GeometriesArrayType(); typedef typename Geometry::Pointer FacePointerType; @@ -985,8 +1001,8 @@ template class PrismInterface3D6 * * @return the value of the shape function at the given point */ - virtual double ShapeFunctionValue( IndexType ShapeFunctionIndex, - const CoordinatesArrayType& rPoint ) const + double ShapeFunctionValue( IndexType ShapeFunctionIndex, + const CoordinatesArrayType& rPoint ) const override { switch ( ShapeFunctionIndex ) { @@ -1020,7 +1036,7 @@ template class PrismInterface3D6 @see ShapeFunctionsLocalGradients @see ShapeFunctionLocalGradient */ - virtual Vector& ShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType& rCoordinates) const + Vector& ShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType& rCoordinates) const override { if(rResult.size() != 6) rResult.resize(6,false); rResult[0] = 1.0 -( rCoordinates[0] + rCoordinates[1] + rCoordinates[2] - ( rCoordinates[0]*rCoordinates[2] ) - ( rCoordinates[1]*rCoordinates[2] ) ); @@ -1029,7 +1045,7 @@ template class PrismInterface3D6 rResult[3] = rCoordinates[2] - ( rCoordinates[0]*rCoordinates[2] ) - ( rCoordinates[1]*rCoordinates[2] ); rResult[4] = rCoordinates[0]*rCoordinates[2]; rResult[5] = rCoordinates[1]*rCoordinates[2]; - + return rResult; } @@ -1049,9 +1065,9 @@ template class PrismInterface3D6 * KLUDGE: method call only works with explicit JacobiansType rather than creating * JacobiansType within argument list */ - virtual ShapeFunctionsGradientsType& ShapeFunctionsIntegrationPointsGradients( + ShapeFunctionsGradientsType& ShapeFunctionsIntegrationPointsGradients( ShapeFunctionsGradientsType& rResult, - IntegrationMethod ThisMethod ) const + IntegrationMethod ThisMethod ) const override { const unsigned int integration_points_number = msGeometryData.IntegrationPointsNumber( ThisMethod ); @@ -1108,7 +1124,7 @@ template class PrismInterface3D6 * @see PrintData() * @see PrintInfo() */ - virtual std::string Info() const + std::string Info() const override { return "3 dimensional interface Prism with six nodes in 3D space"; } @@ -1119,7 +1135,7 @@ template class PrismInterface3D6 * @see PrintData() * @see Info() */ - virtual void PrintInfo( std::ostream& rOStream ) const + void PrintInfo( std::ostream& rOStream ) const override { rOStream << "3 dimensional interface Prism with six nodes in 3D space"; } @@ -1138,7 +1154,7 @@ template class PrismInterface3D6 * :TODO: needs to be reviewed because it is not properly implemented yet * (comment by janosch) */ - virtual void PrintData( std::ostream& rOStream ) const + void PrintData( std::ostream& rOStream ) const override { BaseType::PrintData( rOStream ); std::cout << std::endl; @@ -1147,48 +1163,6 @@ template class PrismInterface3D6 rOStream << " Jacobian in the origin\t : " << jacobian; } - /** - * Calculates the local gradients for all integration points for - * given integration method - */ - virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients( - IntegrationMethod ThisMethod ) - { - ShapeFunctionsGradientsType localGradients - = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod ); - const int integration_points_number - = msGeometryData.IntegrationPointsNumber( ThisMethod ); - ShapeFunctionsGradientsType Result( integration_points_number ); - - for ( int pnt = 0; pnt < integration_points_number; pnt++ ) - { - Result[pnt] = localGradients[pnt]; - } - - return Result; - } - - /** - * Calculates the local gradients for all integration points for the - * default integration method - */ - virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients() - { - IntegrationMethod ThisMethod = msGeometryData.DefaultIntegrationMethod(); - ShapeFunctionsGradientsType localGradients - = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod ); - const int integration_points_number - = msGeometryData.IntegrationPointsNumber( ThisMethod ); - ShapeFunctionsGradientsType Result( integration_points_number ); - - for ( int pnt = 0; pnt < integration_points_number; pnt++ ) - { - Result[pnt] = localGradients[pnt]; - } - - return Result; - } - /** * Calculates the gradients in terms of local coordinates * of all shape functions in a given point. @@ -1198,12 +1172,12 @@ template class PrismInterface3D6 * @return the gradients of all shape functions * \f$ \frac{\partial N^i}{\partial \xi_j} \f$ */ - virtual Matrix& ShapeFunctionsLocalGradients( Matrix& rResult, - const CoordinatesArrayType& rPoint ) const + Matrix& ShapeFunctionsLocalGradients( Matrix& rResult, + const CoordinatesArrayType& rPoint ) const override { rResult.resize( 6, 3, false ); noalias( rResult ) = ZeroMatrix( 6, 3 ); - + rResult( 0, 0 ) = -1.0 + rPoint[2]; rResult( 0, 1 ) = -1.0 + rPoint[2]; rResult( 0, 2 ) = -1.0 + rPoint[0] + rPoint[1]; @@ -1232,55 +1206,14 @@ template class PrismInterface3D6 } - - /** - * returns the shape function gradients in an arbitrary point, - * given in local coordinates - * - * @param rResult the matrix of gradients, - * will be overwritten with the gradients for all - * shape functions in given point - * @param rPoint the given point the gradients are calculated in - */ - virtual Matrix& ShapeFunctionsGradients( Matrix& rResult, PointType& rPoint ) - { - rResult.resize( 6, 3, false ); - noalias( rResult ) = ZeroMatrix( 6, 3 ); - - rResult( 0, 0 ) = -1.0 + rPoint.Z(); - rResult( 0, 1 ) = -1.0 + rPoint.Z(); - rResult( 0, 2 ) = -1.0 + rPoint.X() + rPoint.Y(); - - rResult( 1, 0 ) = 1.0 - rPoint.Z(); - rResult( 1, 1 ) = 0.0; - rResult( 1, 2 ) = -rPoint.X(); - - rResult( 2, 0 ) = 0.0; - rResult( 2, 1 ) = 1.0 - rPoint.Z(); - rResult( 2, 2 ) = -rPoint.Y(); - - rResult( 3, 0 ) = -rPoint.Z(); - rResult( 3, 1 ) = -rPoint.Z(); - rResult( 3, 2 ) = 1.0 - rPoint.X() - rPoint.Y(); - - rResult( 4, 0 ) = rPoint.Z(); - rResult( 4, 1 ) = 0.0; - rResult( 4, 2 ) = rPoint.X(); - - rResult( 5, 0 ) = 0.0; - rResult( 5, 1 ) = rPoint.Z(); - rResult( 5, 2 ) = rPoint.Y(); - - return rResult; - } - /** * returns the second order derivatives of all shape functions * in given arbitrary pointers * @param rResult a third order tensor which contains the second derivatives * @param rPoint the given point the second order derivatives are calculated in */ - virtual ShapeFunctionsSecondDerivativesType& ShapeFunctionsSecondDerivatives( ShapeFunctionsSecondDerivativesType& rResult, const CoordinatesArrayType& rPoint ) const + ShapeFunctionsSecondDerivativesType& ShapeFunctionsSecondDerivatives( ShapeFunctionsSecondDerivativesType& rResult, + const CoordinatesArrayType& rPoint ) const override { if ( rResult.size() != this->PointsNumber() ) { @@ -1289,13 +1222,13 @@ template class PrismInterface3D6 ShapeFunctionsGradientsType temp( this->PointsNumber() ); rResult.swap( temp ); } - + //TODO: this is not correct for a prism - + rResult[0].resize( 2, 2 , false); rResult[1].resize( 2, 2 , false); rResult[2].resize( 2, 2 , false); - + rResult[0]( 0, 0 ) = 0.0; rResult[0]( 0, 1 ) = 0.0; rResult[0]( 1, 0 ) = 0.0; @@ -1317,7 +1250,8 @@ template class PrismInterface3D6 * @param rResult a fourth order tensor which contains the third derivatives * @param rPoint the given point the third order derivatives are calculated in */ - virtual ShapeFunctionsThirdDerivativesType& ShapeFunctionsThirdDerivatives( ShapeFunctionsThirdDerivativesType& rResult, const CoordinatesArrayType& rPoint ) const + ShapeFunctionsThirdDerivativesType& ShapeFunctionsThirdDerivatives( ShapeFunctionsThirdDerivativesType& rResult, + const CoordinatesArrayType& rPoint ) const override { if ( rResult.size() != this->PointsNumber() ) { @@ -1333,9 +1267,9 @@ template class PrismInterface3D6 boost::numeric::ublas::vector temp( this->PointsNumber() ); rResult[i].swap( temp ); } - + //TODO: this is not correct for a prism - + rResult[0][0].resize( 2, 2 , false); rResult[0][1].resize( 2, 2 , false); rResult[1][0].resize( 2, 2 , false); @@ -1381,12 +1315,12 @@ template class PrismInterface3D6 friend class Serializer; - virtual void save( Serializer& rSerializer ) const + void save( Serializer& rSerializer ) const override { KRATOS_SERIALIZE_SAVE_BASE_CLASS( rSerializer, BaseType ); } - virtual void load( Serializer& rSerializer ) + void load( Serializer& rSerializer ) override { KRATOS_SERIALIZE_LOAD_BASE_CLASS( rSerializer, BaseType ); } @@ -1466,8 +1400,7 @@ template class PrismInterface3D6 * @return the vector of the gradients of all shape functions * in each integration point */ - static ShapeFunctionsGradientsType - CalculateShapeFunctionsIntegrationPointsLocalGradients( + static ShapeFunctionsGradientsType CalculateShapeFunctionsIntegrationPointsLocalGradients( typename BaseType::IntegrationMethod ThisMethod ) { IntegrationPointsContainerType all_integration_points = diff --git a/kratos/geometries/quadrilateral_2d_4.h b/kratos/geometries/quadrilateral_2d_4.h index ce27bd55aeb6..4e2099e549e6 100644 --- a/kratos/geometries/quadrilateral_2d_4.h +++ b/kratos/geometries/quadrilateral_2d_4.h @@ -27,8 +27,6 @@ #include "integration/quadrilateral_gauss_legendre_integration_points.h" #include "integration/quadrilateral_collocation_integration_points.h" - - namespace Kratos { ///@name Kratos Globals @@ -447,25 +445,36 @@ template class Quadrilateral2D4 */ double DomainSize() const override { - return fabs( this->DeterminantOfJacobian( PointType() ) ) * 0.5; + return std::abs( this->DeterminantOfJacobian( PointType() ) ) * 0.5; } /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if ( fabs(rResult[0]) <= (1.0+Tolerance) ) - if ( fabs(rResult[1]) <= (1.0+Tolerance) ) + if ( std::abs(rResult[0]) <= (1.0+Tolerance) ) + { + if ( std::abs(rResult[1]) <= (1.0+Tolerance) ) + { return true; + } + } return false; } - - /** This method gives you number of all edges of this geometry. This method will gives you number of all the edges with one dimension less than this geometry. for example a diff --git a/kratos/geometries/quadrilateral_2d_8.h b/kratos/geometries/quadrilateral_2d_8.h index e43637d703e9..2dc87714b36f 100644 --- a/kratos/geometries/quadrilateral_2d_8.h +++ b/kratos/geometries/quadrilateral_2d_8.h @@ -396,11 +396,10 @@ template class Quadrilateral2D8 */ double Area() const override { - Vector temp; DeterminantOfJacobian( temp, msGeometryData.DefaultIntegrationMethod() ); const IntegrationPointsArrayType& integration_points = this->IntegrationPoints( msGeometryData.DefaultIntegrationMethod() ); - double Area = 0.00; + double Area = 0.0; for ( unsigned int i = 0; i < integration_points.size(); i++ ) { @@ -431,19 +430,32 @@ template class Quadrilateral2D8 */ double DomainSize() const override { - return fabs( DeterminantOfJacobian( PointType() ) ) * 0.5; + return std::abs( DeterminantOfJacobian( PointType() ) ) * 0.5; } /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if ( fabs( rResult[0] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[1] ) <= (1.0 + Tolerance) ) + if ( std::abs( rResult[0] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[1] ) <= (1.0 + Tolerance) ) + { return true; + } + } return false; } @@ -604,8 +616,7 @@ template class Quadrilateral2D8 ThisMethod ), IntegrationPointIndex ); //Elements of jacobian matrix (e.g. J(1,1) = dX1/dXi1) - //loop over all nodes - + // Loop over all nodes for ( unsigned int i = 0; i < this->PointsNumber(); i++ ) { rResult( 0, 0 ) += @@ -674,10 +685,12 @@ template class Quadrilateral2D8 * @see Jacobian * @see InverseOfJacobian */ - Vector& DeterminantOfJacobian( Vector& rResult, - IntegrationMethod ThisMethod ) const override + Vector& DeterminantOfJacobian( + Vector& rResult, + IntegrationMethod ThisMethod + ) const override { - //workaround by riccardo + // Workaround by riccardo if ( rResult.size() != this->IntegrationPointsNumber( ThisMethod ) ) { // KLUDGE: While there is a bug in ublas @@ -815,20 +828,23 @@ template class Quadrilateral2D8 */ Matrix& InverseOfJacobian( Matrix& rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod ) const override { - //current jacobian + // Current jacobian Matrix tempMatrix = ZeroMatrix( 2, 2 ); tempMatrix = Jacobian( tempMatrix, IntegrationPointIndex, ThisMethod ); - //determinant of jacobian - double det_j = DeterminantOfJacobian( IntegrationPointIndex, ThisMethod ); - //checking for singularity - + + // Determinant of jacobian + const double det_j = DeterminantOfJacobian( IntegrationPointIndex, ThisMethod ); + + // Checking for singularity if ( det_j == 0.00 ) + { KRATOS_ERROR << "Zero determinant of jacobian." << *this << std::endl; + } - //setting up result matrix + // Setting up result matrix rResult.resize( 2, 2 ); - //filling matrix + // Filling matrix rResult( 0, 0 ) = ( tempMatrix( 1, 1 ) ) / ( det_j ); rResult( 1, 0 ) = -( tempMatrix( 1, 0 ) ) / ( det_j ); @@ -865,8 +881,10 @@ template class Quadrilateral2D8 double det_j = DeterminantOfJacobian( rPoint ); //checking for singularity - if ( det_j == 0.00 ) + if ( det_j == 0.0 ) + { KRATOS_ERROR << "Zero determinant of jacobian." << *this << std::endl; + } //setting up result matrix rResult.resize( 2, 2 ); @@ -940,76 +958,76 @@ template class Quadrilateral2D8 { switch ( ShapeFunctionIndex ) { - case 0: - return -(( 1.0 - rPoint[0] )*( 1.0 - rPoint[1] ) - *( 1.0 + rPoint[0] - + rPoint[1] ) ) / 4.0; - case 1: - return -(( 1.0 + rPoint[0] ) - *( 1.0 - rPoint[1] )*( 1.0 - - rPoint[0] + rPoint[1] ) ) / 4.0; - case 2 : - return -(( 1.0 + rPoint[0] ) - *( 1.0 + rPoint[1] )*( 1.0 - - rPoint[0] - rPoint[1] ) ) / 4.0; - case 3 : - return -(( 1.0 - rPoint[0] )*( 1.0 - + rPoint[1] )*( 1.0 )*( 1.0 - + rPoint[0] - rPoint[1] ) ) / 4.0; - case 4 : - return (( 1.0 -rPoint[0]*rPoint[0] ) - *( 1.0 - rPoint[1] ) ) / 2.0; - case 5 : - return (( 1.0 + rPoint[0] ) - *( 1.0 - rPoint[1]*rPoint[1] ) ) / 2.0 ; - case 6 : - return (( 1.0 -rPoint[0] - *rPoint[0] )*( 1.0 + rPoint[1] ) ) / 2.0 ; - case 7 : - return (( 1.0 -rPoint[0] ) - *( 1.0 - rPoint[1]*rPoint[1] ) ) / 2.0 ; - default: - KRATOS_ERROR << "Wrong index of shape function!" << *this << std::endl; + // Primary nodes + case 0: + return -(( 1.0 - rPoint[0] )*( 1.0 - rPoint[1] ) + *( 1.0 + rPoint[0] + rPoint[1] ) ) / 4.0; + case 1: + return -(( 1.0 + rPoint[0] )*( 1.0 - rPoint[1] ) + *( 1.0 - rPoint[0] + rPoint[1] ) ) / 4.0; + case 2: + return -(( 1.0 + rPoint[0] )*( 1.0 + rPoint[1] ) + *( 1.0 - rPoint[0] - rPoint[1] ) ) / 4.0; + case 3: + return -(( 1.0 - rPoint[0] )*( 1.0 + rPoint[1] ) + *( 1.0 + rPoint[0] - rPoint[1] ) ) / 4.0; + // Secondary nodes + case 4: + return (( 1.0 -rPoint[0]*rPoint[0] ) + *( 1.0 - rPoint[1] ) ) / 2.0; + case 5: + return (( 1.0 + rPoint[0] ) + *( 1.0 - rPoint[1]*rPoint[1] ) ) / 2.0 ; + case 6: + return (( 1.0 -rPoint[0]*rPoint[0] ) + *( 1.0 + rPoint[1] ) ) / 2.0 ; + case 7: + return (( 1.0 -rPoint[0] ) + *( 1.0 - rPoint[1]*rPoint[1] ) ) / 2.0 ; + default: + KRATOS_ERROR << "Wrong index of shape function!" << *this << std::endl; } return 0; } - /** This method gives all non-zero shape functions values - evaluated at the rCoordinates provided - - @return Vector of values of shape functions \f$ F_{i} \f$ - where i is the shape function index (for NURBS it is the index - of the local enumeration in the element). - - @see ShapeFunctionValue - @see ShapeFunctionsLocalGradients - @see ShapeFunctionLocalGradient - */ - Vector& ShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType& rCoordinates) const override + /** This method gives all non-zero shape functions values evaluated at the rCoordinates provided + * @return Vector of values of shape functions \f$ F_{i} \f$ where i is the shape function index + * (for NURBS it is the index + * of the local enumeration in the element). + * @see ShapeFunctionValue + * @see ShapeFunctionsLocalGradients + * @see ShapeFunctionLocalGradient + */ + Vector& ShapeFunctionsValues ( + Vector &rResult, + const CoordinatesArrayType& rCoordinates + ) const override { - if(rResult.size() != 8) rResult.resize(8,false); - - rResult[0] = -(( 1.0 - rCoordinates[0] )*( 1.0 - rCoordinates[1] ) - *( 1.0 + rCoordinates[0] - + rCoordinates[1] ) ) / 4.0; - rResult[1] = -(( 1.0 + rCoordinates[0] ) - *( 1.0 - rCoordinates[1] )*( 1.0 - - rCoordinates[0] + rCoordinates[1] ) ) / 4.0; - rResult[2] = -(( 1.0 + rCoordinates[0] ) - *( 1.0 + rCoordinates[1] )*( 1.0 - - rCoordinates[0] - rCoordinates[1] ) ) / 4.0; - rResult[3] = -(( 1.0 - rCoordinates[0] )*( 1.0 - + rCoordinates[1] )*( 1.0 )*( 1.0 - + rCoordinates[0] - rCoordinates[1] ) ) / 4.0; - rResult[4] = (( 1.0 -rCoordinates[0]*rCoordinates[0] ) - *( 1.0 - rCoordinates[1] ) ) / 2.0; - rResult[5] = (( 1.0 + rCoordinates[0] ) - *( 1.0 - rCoordinates[1]*rCoordinates[1] ) ) / 2.0 ; - rResult[6] = (( 1.0 -rCoordinates[0] - *rCoordinates[0] )*( 1.0 + rCoordinates[1] ) ) / 2.0 ; - rResult[7] = (( 1.0 -rCoordinates[0] ) - *( 1.0 - rCoordinates[1]*rCoordinates[1] ) ) / 2.0 ; + if(rResult.size() != 8) + { + rResult.resize(8,false); + } + + // Primary nodes + rResult[0] = -(( 1.0 - rCoordinates[0] )*( 1.0 - rCoordinates[1] ) + *( 1.0 + rCoordinates[0] + rCoordinates[1] ) ) / 4.0; + rResult[1] = -(( 1.0 + rCoordinates[0] )*( 1.0 - rCoordinates[1] ) + *( 1.0 - rCoordinates[0] + rCoordinates[1] ) ) / 4.0; + rResult[2] = -(( 1.0 + rCoordinates[0] )*( 1.0 + rCoordinates[1] ) + *( 1.0 - rCoordinates[0] - rCoordinates[1] ) ) / 4.0; + rResult[3] = -(( 1.0 - rCoordinates[0] )*( 1.0 + rCoordinates[1] ) + *( 1.0 + rCoordinates[0] - rCoordinates[1] ) ) / 4.0; + + // Secondary nodes + rResult[4] = (( 1.0 -rCoordinates[0]*rCoordinates[0] ) + *( 1.0 - rCoordinates[1] ) ) / 2.0; + rResult[5] = (( 1.0 + rCoordinates[0] ) + *( 1.0 - rCoordinates[1]*rCoordinates[1] ) ) / 2.0 ; + rResult[6] = (( 1.0 -rCoordinates[0]*rCoordinates[0] ) + *( 1.0 + rCoordinates[1] ) ) / 2.0 ; + rResult[7] = (( 1.0 -rCoordinates[0] ) + *( 1.0 - rCoordinates[1]*rCoordinates[1] ) ) / 2.0 ; return rResult; } @@ -1039,7 +1057,9 @@ template class Quadrilateral2D8 msGeometryData.IntegrationPointsNumber( ThisMethod ); if ( integration_points_number == 0 ) + { KRATOS_ERROR << "This integration method is not supported" << *this << std::endl; + } //workaround by riccardo if ( rResult.size() != integration_points_number ) @@ -1167,49 +1187,44 @@ template class Quadrilateral2D8 /** * Calculates the gradients in terms of local coordinates * of all shape functions in a given point. - * * @param rPoint the current point at which the gradients are calculated * @return the gradients of all shape functions * \f$ \frac{\partial N^i}{\partial \xi_j} \f$ */ - Matrix& ShapeFunctionsLocalGradients( Matrix& rResult, - const CoordinatesArrayType& rPoint ) const override + Matrix& ShapeFunctionsLocalGradients( + Matrix& rResult, + const CoordinatesArrayType& rPoint + ) const override { - //setting up result matrix + // Setting up result matrix rResult.resize( 8, 2 ); noalias( rResult ) = ZeroMatrix( 8, 2 ); - rResult( 0, 0 ) = (( -1.0 + rPoint[1] ) * ( -2.0 ) * ( 1.0 + 2.0 - * rPoint[0] + rPoint[1] - 1.0 ) ) / 8.0; - rResult( 0, 1 ) = (( -1.0 + rPoint[0] ) * ( -2.0 ) * ( 1.0 + rPoint[0] + 2.0 - * rPoint[1] - 1.0 ) ) / 8.0; + // Primary nodes + rResult( 0, 0 ) = - ((-1.0 + rPoint[1])*( 2.0 * rPoint[0] + rPoint[1])) / 4.0; + rResult( 0, 1 ) = - ((-1.0 + rPoint[0])*( 2.0 * rPoint[1] + rPoint[0])) / 4.0; - rResult( 1, 0 ) = -(( -1.0 + rPoint[1] ) * ( -2.0 ) * ( 1.0 - 2.0 - * rPoint[0] + rPoint[1] - 1.0 ) ) / 8.0; - rResult( 1, 1 ) = (( 1.0 + rPoint[0] ) * ( -1.0 + rPoint[0] - 2.0 - * rPoint[1] + 1.0 ) * ( -2.0 ) ) / 8.0; + rResult( 1, 0 ) = ((-1.0 + rPoint[1])*(-2.0 * rPoint[0] + rPoint[1])) / 4.0; + rResult( 1, 1 ) = (( 1.0 + rPoint[0])*( 2.0 * rPoint[1] - rPoint[0])) / 4.0; - rResult( 2, 0 ) = -(( 1.0 + rPoint[1] ) * ( -1.0 + 2.0 - * rPoint[0] + rPoint[1] + 1.0 ) * ( -2.0 ) ) / 8.0; - rResult( 2, 1 ) = -(( 1.0 + rPoint[0] ) * ( -1.0 + rPoint[0] + 2.0 - * rPoint[1] + 1.0 ) * ( -2.0 ) ) / 8.0; + rResult( 2, 0 ) = (( 1.0 + rPoint[1])*( 2.0 * rPoint[0] + rPoint[1])) / 4.0; + rResult( 2, 1 ) = (( 1.0 + rPoint[0])*( 2.0 * rPoint[1] + rPoint[0])) / 4.0; - rResult( 3, 0 ) = (( 1.0 + rPoint[1] ) * ( -1.0 - 2.0 - * rPoint[0] + rPoint[1] + 1.0 ) * ( -2.0 ) ) / 8.0; - rResult( 3, 1 ) = -(( -1.0 + rPoint[0] ) * ( -2.0 ) * ( 1.0 + rPoint[0] - 2.0 - * rPoint[1] - 1.0 ) ) / 8.0; + rResult( 3, 0 ) = - (( 1.0 + rPoint[1])*(-2.0 * rPoint[0] + rPoint[1])) / 4.0; + rResult( 3, 1 ) = - ((-1.0 + rPoint[0])*( 2.0 * rPoint[1] - rPoint[0])) / 4.0; - rResult( 4, 0 ) = -( rPoint[0] * ( -1.0 + rPoint[1] ) * ( -2.0 ) ) / 2.0; - rResult( 4, 1 ) = -(( -1.0 + rPoint[0] * rPoint[0] ) * ( -2.0 ) ) / 4.0; + // Secondary nodes + rResult( 4, 0 ) = rPoint[0] * (-1.0 + rPoint[1]); + rResult( 4, 1 ) = ((1.0 + rPoint[0]) * (-1.0 + rPoint[0])) / 2.0; - rResult( 5, 0 ) = (( -1.0 + rPoint[1] * rPoint[1] ) * ( -2.0 ) ) / 4.0; - rResult( 5, 1 ) = (( 1.0 + rPoint[0] ) * rPoint[1] * ( -2.0 ) ) / 2.0; + rResult( 5, 0 ) = - ((1.0 + rPoint[1]) * (-1.0 + rPoint[1])) / 2.0; + rResult( 5, 1 ) = - rPoint[1] * ( 1.0 + rPoint[0]); - rResult( 6, 0 ) = ( rPoint[0] * ( 1.0 + rPoint[1] ) * ( -2.0 ) ) / 2.0; - rResult( 6, 1 ) = (( -1.0 + rPoint[0] * rPoint[0] ) * ( -2.0 ) ) / 4.0; + rResult( 6, 0 ) = - rPoint[0] * ( 1.0 + rPoint[1]); + rResult( 6, 1 ) = - ((1.0 + rPoint[0]) * (-1.0 + rPoint[0])) / 2.0; - rResult( 7, 0 ) = -(( -1.0 + rPoint[1] * rPoint[1] ) * ( -2.0 ) ) / 4.0; - rResult( 7, 1 ) = -(( -1.0 + rPoint[0] ) * rPoint[1] * ( -2.0 ) ) / 2.0; + rResult( 7, 0 ) = ((1.0 + rPoint[1]) * (-1.0 + rPoint[1])) / 2.0; + rResult( 7, 1 ) = rPoint[1] * (-1.0 + rPoint[0]); return( rResult ); } @@ -1243,7 +1258,7 @@ template class Quadrilateral2D8 } /** - * returns the shape function gradients in an arbitrary point, + * Returns the shape function gradients in an arbitrary point, * given in local coordinates * @param rResult the matrix of gradients, will be overwritten * with the gradients for all @@ -1255,45 +1270,16 @@ template class Quadrilateral2D8 rResult.resize( 8, 2 ); noalias( rResult ) = ZeroMatrix( 8, 2 ); - rResult( 0, 0 ) = (( -1.0 + rPoint.Y() ) * ( -2.0 ) * ( 1.0 + 2.0 - * rPoint.X() + rPoint.Y() - 1.0 ) ) / 8.0; - rResult( 0, 1 ) = (( -1.0 + rPoint.X() ) * ( -2.0 ) * ( 1.0 + rPoint.X() + 2.0 - * rPoint.Y() - 1.0 ) ) / 8.0; - - rResult( 1, 0 ) = -(( -1.0 + rPoint.Y() ) * ( -2.0 ) * ( 1.0 - 2.0 - * rPoint.X() + rPoint.Y() - 1.0 ) ) / 8.0; - rResult( 1, 1 ) = (( 1.0 + rPoint.X() ) * ( -1.0 + rPoint.X() - 2.0 - * rPoint.Y() + 1.0 ) * ( -2.0 ) ) / 8.0; - - rResult( 2, 0 ) = -(( 1.0 + rPoint.Y() ) * ( -1.0 + 2.0 - * rPoint.X() + rPoint.Y() + 1.0 ) * ( -2.0 ) ) / 8.0; - rResult( 2, 1 ) = -(( 1.0 + rPoint.X() ) * ( -1.0 + rPoint.X() + 2.0 - * rPoint.Y() + 1.0 ) * ( -2.0 ) ) / 8.0; - - rResult( 3, 0 ) = (( 1.0 + rPoint.Y() ) * ( -1.0 - 2.0 - * rPoint.X() + rPoint.Y() + 1.0 ) * ( -2.0 ) ) / 8.0; - rResult( 3, 1 ) = -(( -1.0 + rPoint.X() ) * ( -2.0 ) * ( 1.0 + rPoint.X() - 2.0 - * rPoint.Y() - 1.0 ) ) / 8.0; - - rResult( 4, 0 ) = -( rPoint.X() * ( -1.0 + rPoint.Y() ) * ( -2.0 ) ) / 2.0; - rResult( 4, 1 ) = -(( -1.0 + rPoint.X() * rPoint.X() ) * ( -2.0 ) ) / 4.0; - - rResult( 5, 0 ) = (( -1.0 + rPoint.Y() * rPoint.Y() ) * ( -2.0 ) ) / 4.0; - rResult( 5, 1 ) = (( 1.0 + rPoint.X() ) * rPoint.Y() * ( -2.0 ) ) / 2.0; - - rResult( 6, 0 ) = ( rPoint.X() * ( 1.0 + rPoint.Y() ) * ( -2.0 ) ) / 2.0; - rResult( 6, 1 ) = (( -1.0 + rPoint.X() * rPoint.X() ) * ( -2.0 ) ) / 4.0; - - rResult( 7, 0 ) = -(( -1.0 + rPoint.Y() * rPoint.Y() ) * ( -2.0 ) ) / 4.0; - rResult( 7, 1 ) = -(( -1.0 + rPoint.X() ) * rPoint.Y() * ( -2.0 ) ) / 2.0; + const CoordinatesArrayType& Coords = rPoint.Coordinates(); + + rResult = ShapeFunctionsLocalGradients(rResult, Coords); return rResult; } /** - * returns the second order derivatives of all shape functions + * Returns the second order derivatives of all shape functions * in given arbitrary points - * * @param rResult a third order tensor which contains the second derivatives * @param rPoint the given point the second order derivatives are calculated in */ @@ -1366,13 +1352,16 @@ template class Quadrilateral2D8 } /** - * returns the third order derivatives of all shape functions - * in given arbitrary points - * - * @param rResult a fourth order tensor which contains the third derivatives - * @param rPoint the given point the third order derivatives are calculated in + * Returns the third order derivatives of all shape functions + * in given arbitrary points + * + * @param rResult a fourth order tensor which contains the third derivatives + * @param rPoint the given point the third order derivatives are calculated in */ - ShapeFunctionsThirdDerivativesType& ShapeFunctionsThirdDerivatives( ShapeFunctionsThirdDerivativesType& rResult, const CoordinatesArrayType& rPoint ) const override + ShapeFunctionsThirdDerivativesType& ShapeFunctionsThirdDerivatives( + ShapeFunctionsThirdDerivativesType& rResult, + const CoordinatesArrayType& rPoint + ) const override { if ( rResult.size() != this->PointsNumber() ) @@ -1468,10 +1457,6 @@ template class Quadrilateral2D8 return rResult; } - - - - protected: /** @@ -1509,8 +1494,6 @@ template class Quadrilateral2D8 * Private Operations */ - - /** * :TODO: implemented but not yet tested */ @@ -1526,16 +1509,20 @@ template class Quadrilateral2D8 { IntegrationPointsContainerType all_integration_points = AllIntegrationPoints(); IntegrationPointsArrayType integration_points = all_integration_points[ThisMethod]; - //number of integration points - const int integration_points_number = integration_points.size(); - //number of nodes in current geometry - const int points_number = 8; - //setting up return matrix + + // Number of integration points + const unsigned int integration_points_number = integration_points.size(); + + // Number of nodes in current geometry + const unsigned int points_number = 8; + + // Setting up return matrix Matrix shape_function_values( integration_points_number, points_number ); - //loop over all integration points - - for ( int pnt = 0; pnt < integration_points_number; pnt++ ) + + // Loop over all integration points + for ( unsigned int pnt = 0; pnt < integration_points_number; pnt++ ) { + // Primary nodes row( shape_function_values, pnt )( 0 ) = -(( 1.0 - integration_points[pnt].X() ) * ( 1.0 - integration_points[pnt].Y() ) @@ -1554,8 +1541,10 @@ template class Quadrilateral2D8 row( shape_function_values, pnt )( 3 ) = -(( 1.0 - integration_points[pnt].X() ) * ( 1.0 + integration_points[pnt].Y() ) * ( 1.0 ) * ( 1.0 - + integration_points[pnt].X() - - integration_points[pnt].Y() ) ) / 4.0; + + integration_points[pnt].X() + - integration_points[pnt].Y() ) ) / 4.0; + + // Secondary nodes row( shape_function_values, pnt )( 4 ) = (( 1.0 - integration_points[pnt].X() * integration_points[pnt].X() ) @@ -1589,80 +1578,47 @@ template class Quadrilateral2D8 * point */ static ShapeFunctionsGradientsType - CalculateShapeFunctionsIntegrationPointsLocalGradients( - typename BaseType::IntegrationMethod ThisMethod ) + CalculateShapeFunctionsIntegrationPointsLocalGradients(typename BaseType::IntegrationMethod ThisMethod ) { IntegrationPointsContainerType all_integration_points = AllIntegrationPoints(); IntegrationPointsArrayType integration_points = all_integration_points[ThisMethod]; - //number of integration points - const int integration_points_number = integration_points.size(); + // Number of integration points + const unsigned int integration_points_number = integration_points.size(); ShapeFunctionsGradientsType d_shape_f_values( integration_points_number ); - //initialising container + // Initialising container //std::fill(d_shape_f_values.begin(), d_shape_f_values.end(), Matrix(4,2)); - //loop over all integration points - - for ( int pnt = 0; pnt < integration_points_number; pnt++ ) + + // Loop over all integration points + for ( unsigned int pnt = 0; pnt < integration_points_number; pnt++ ) { Matrix result = ZeroMatrix( 8, 2 ); + + // Primary nodes + result( 0, 0 ) = - ((-1.0 + integration_points[pnt].Y())*( 2.0 * integration_points[pnt].X() + integration_points[pnt].Y())) / 4.0; + result( 0, 1 ) = - ((-1.0 + integration_points[pnt].X())*( 2.0 * integration_points[pnt].Y() + integration_points[pnt].X())) / 4.0; + + result( 1, 0 ) = ((-1.0 + integration_points[pnt].Y())*(-2.0 * integration_points[pnt].X() + integration_points[pnt].Y())) / 4.0; + result( 1, 1 ) = (( 1.0 + integration_points[pnt].X())*( 2.0 * integration_points[pnt].Y() - integration_points[pnt].X())) / 4.0; + + result( 2, 0 ) = (( 1.0 + integration_points[pnt].Y())*( 2.0 * integration_points[pnt].X() + integration_points[pnt].Y())) / 4.0; + result( 2, 1 ) = (( 1.0 + integration_points[pnt].X())*( 2.0 * integration_points[pnt].Y() + integration_points[pnt].X())) / 4.0; + + result( 3, 0 ) = - (( 1.0 + integration_points[pnt].Y())*(-2.0 * integration_points[pnt].X() + integration_points[pnt].Y())) / 4.0; + result( 3, 1 ) = - ((-1.0 + integration_points[pnt].X())*( 2.0 * integration_points[pnt].Y() - integration_points[pnt].X())) / 4.0; + + // Secondary nodes + result( 4, 0 ) = integration_points[pnt].X() * (-1.0 + integration_points[pnt].Y()); + result( 4, 1 ) = ((1.0 + integration_points[pnt].X()) * (-1.0 + integration_points[pnt].X())) / 2.0; - result( 0, 0 ) = (( -1.0 + integration_points[pnt].Y() ) - * ( -2.0 ) * ( 1.0 + 2.0 - * integration_points[pnt].X() - + integration_points[pnt].Y() - 1.0 ) ) / 8.0; - result( 0, 1 ) = (( -1.0 + integration_points[pnt].X() ) * ( -2.0 ) * ( 1.0 - + integration_points[pnt].X() + 2.0 - * integration_points[pnt].Y() - 1.0 ) ) / 8.0; - - result( 1, 0 ) = -(( -1.0 + integration_points[pnt].Y() ) - * ( -2.0 ) * ( 1.0 - 2.0 * integration_points[pnt].X() - + integration_points[pnt].Y() - 1.0 ) ) / 8.0; - result( 1, 1 ) = (( 1.0 + integration_points[pnt].X() ) * ( -1.0 - + integration_points[pnt].X() - 2.0 - * integration_points[pnt].Y() + 1.0 ) * ( -2.0 ) ) / 8.0; - - result( 2, 0 ) = -(( 1.0 + integration_points[pnt].Y() ) - * ( -1.0 + 2.0 * integration_points[pnt].X() - + integration_points[pnt].Y() + 1.0 ) * ( -2.0 ) ) / 8.0; - result( 2, 1 ) = -(( 1.0 + integration_points[pnt].X() ) * ( -1.0 - + integration_points[pnt].X() + 2.0 - * integration_points[pnt].Y() + 1.0 ) * ( -2.0 ) ) / 8.0; - - result( 3, 0 ) = (( 1.0 + integration_points[pnt].Y() ) * ( -1.0 - 2.0 - * integration_points[pnt].X() - + integration_points[pnt].Y() + 1.0 ) * ( -2.0 ) ) / 8.0; - result( 3, 1 ) = -(( -1.0 + integration_points[pnt].X() ) * ( -2.0 ) * ( 1.0 - + integration_points[pnt].X() - 2.0 - * integration_points[pnt].Y() - 1.0 ) ) / 8.0; - - result( 4, 0 ) = -( integration_points[pnt].X() * ( -1.0 - + integration_points[pnt].Y() ) * ( -2.0 ) ) / 2.0; - - result( 4, 1 ) = -(( -1.0 - + integration_points[pnt].X() - * integration_points[pnt].X() ) * ( -2.0 ) ) / 4.0; - - result( 5, 0 ) = (( -1.0 - + integration_points[pnt].Y() - * integration_points[pnt].Y() ) * ( -2.0 ) ) / 4.0; - - result( 5, 1 ) = (( 1.0 - + integration_points[pnt].X() ) - * integration_points[pnt].Y() * ( -2.0 ) ) / 2.0; - - result( 6, 0 ) = ( integration_points[pnt].X() * ( 1.0 - + integration_points[pnt].Y() ) * ( -2.0 ) ) / 2.0; - result( 6, 1 ) = (( -1.0 - + integration_points[pnt].X() - * integration_points[pnt].X() ) * ( -2.0 ) ) / 4.0; - - result( 7, 0 ) = -(( -1.0 - + integration_points[pnt].Y() - * integration_points[pnt].Y() ) * ( -2.0 ) ) / 4.0; - - result( 7, 1 ) = -(( -1.0 - + integration_points[pnt].X() ) - * integration_points[pnt].Y() * ( -2.0 ) ) / 2.0; + result( 5, 0 ) = - ((1.0 + integration_points[pnt].Y()) * (-1.0 + integration_points[pnt].Y())) / 2.0; + result( 5, 1 ) = - integration_points[pnt].Y() * ( 1.0 + integration_points[pnt].X()); + result( 6, 0 ) = - integration_points[pnt].X() * ( 1.0 + integration_points[pnt].Y()); + result( 6, 1 ) = - ((1.0 + integration_points[pnt].X()) * (-1.0 + integration_points[pnt].X())) / 2.0; + + result( 7, 0 ) = ((1.0 + integration_points[pnt].Y()) * (-1.0 + integration_points[pnt].Y())) / 2.0; + result( 7, 1 ) = integration_points[pnt].Y() * (-1.0 + integration_points[pnt].X()); + d_shape_f_values[pnt] = result; } @@ -1683,6 +1639,10 @@ template class Quadrilateral2D8 Quadrature < QuadrilateralGaussLegendreIntegrationPoints2, 2, IntegrationPoint<3> >::GenerateIntegrationPoints(), Quadrature < QuadrilateralGaussLegendreIntegrationPoints3, + 2, IntegrationPoint<3> >::GenerateIntegrationPoints(), + Quadrature < QuadrilateralGaussLegendreIntegrationPoints4, + 2, IntegrationPoint<3> >::GenerateIntegrationPoints(), + Quadrature < QuadrilateralGaussLegendreIntegrationPoints5, 2, IntegrationPoint<3> >::GenerateIntegrationPoints() } }; @@ -1702,7 +1662,11 @@ template class Quadrilateral2D8 Quadrilateral2D8::CalculateShapeFunctionsIntegrationPointsValues( GeometryData::GI_GAUSS_2 ), Quadrilateral2D8::CalculateShapeFunctionsIntegrationPointsValues( - GeometryData::GI_GAUSS_3 ) + GeometryData::GI_GAUSS_3 ), + Quadrilateral2D8::CalculateShapeFunctionsIntegrationPointsValues( + GeometryData::GI_GAUSS_4 ), + Quadrilateral2D8::CalculateShapeFunctionsIntegrationPointsValues( + GeometryData::GI_GAUSS_5 ) } }; return shape_functions_values; @@ -1722,7 +1686,11 @@ template class Quadrilateral2D8 Quadrilateral2D8::CalculateShapeFunctionsIntegrationPointsLocalGradients( GeometryData::GI_GAUSS_2 ), Quadrilateral2D8::CalculateShapeFunctionsIntegrationPointsLocalGradients( - GeometryData::GI_GAUSS_3 ) + GeometryData::GI_GAUSS_3 ), + Quadrilateral2D8::CalculateShapeFunctionsIntegrationPointsLocalGradients( + GeometryData::GI_GAUSS_4 ), + Quadrilateral2D8::CalculateShapeFunctionsIntegrationPointsLocalGradients( + GeometryData::GI_GAUSS_5 ) } }; return shape_functions_local_gradients; diff --git a/kratos/geometries/quadrilateral_2d_9.h b/kratos/geometries/quadrilateral_2d_9.h index 724723619f74..c56d6305fbfe 100644 --- a/kratos/geometries/quadrilateral_2d_9.h +++ b/kratos/geometries/quadrilateral_2d_9.h @@ -431,15 +431,28 @@ template class Quadrilateral2D9 : public Geometry } /** - * Returns whether given arbitrary point is inside the Geometry - */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); if ( (rResult[0] >= (-1.0-Tolerance)) && (rResult[0] <= (1.0+Tolerance)) ) + { if ( (rResult[1] >= (-1.0-Tolerance)) && (rResult[1] <= (1.0+Tolerance)) ) + { return true; + } + } return false; } diff --git a/kratos/geometries/quadrilateral_3d_4.h b/kratos/geometries/quadrilateral_3d_4.h index 0a3e491bddda..ca957ad9d692 100644 --- a/kratos/geometries/quadrilateral_3d_4.h +++ b/kratos/geometries/quadrilateral_3d_4.h @@ -325,7 +325,7 @@ template class Quadrilateral3D4 //making a copy of the nodes TO POINTS (not Nodes!!!) for ( IndexType i = 0 ; i < this->size() ; i++ ) { - NewPoints.push_back(boost::make_shared< Point<3> >(( *this )[i])); + NewPoints.push_back(boost::make_shared< Point<3> >(( *this )[i])); } //creating a geometry with the new points @@ -408,65 +408,65 @@ template class Quadrilateral3D4 */ double Area() const override { - // Old + // Old /*Vector d = this->Points()[2] - this->Points()[0]; return( sqrt( d[0]*d[0] + d[1]*d[1] + d[2]*d[2] ) );*/ - // New - 24/01/2014 - Massimo Petracca - // the following procedure calculates the area of a general - // quadrilateral (flat or warped) using the parametric representation - // of ruled hyperbolic paraboloid surface. - // the integration of the normal is then performed with a 2x2 gauss quadrature - // in the U-V domain [0,1]. - // results explicitly written after symbolic calculation. - - const TPointType& p1 = this->Points()[0]; - const TPointType& p2 = this->Points()[1]; - const TPointType& p3 = this->Points()[2]; - const TPointType& p4 = this->Points()[3]; - - double p1x = p1.X(); - double p1y = p1.Y(); - double p1z = p1.Z(); - - double p2x = p2.X(); - double p2y = p2.Y(); - double p2z = p2.Z(); - - double p3x = p3.X(); - double p3y = p3.Y(); - double p3z = p3.Z(); - - double p4x = p4.X(); - double p4y = p4.Y(); - double p4z = p4.Z(); - - double pos = 0.5 + 0.5 / std::sqrt(3.0); - double w = 0.25; - - double C1 = pos*(p1z - p2z + p3z - p4z); - double C2 = pos*(p1y - p2y + p3y - p4y); - double C3 = pos*(p1x - p2x + p3x - p4x); - double C4 = C1 - p1z + p2z; - double C5 = C1 + p1z - p2z; - double C6 = C2 + p1y - p2y; - double C7 = C2 - p1y + p2y; - double C8 = C3 - p1x + p2x; - double C9 = C3 + p1x - p2x; - double C10 = C1 - p1z + p4z; - double C11 = C2 - p1y + p4y; - double C12 = C3 - p1x + p4x; - double C13 = C1 + p1z - p4z; - double C14 = C2 + p1y - p4y; - double C15 = C3 + p1x - p4x; - - return w * ( - std::sqrt( std::pow(C4*C11 - C7*C10, 2) + std::pow(C4*C12 - C8*C10, 2) + std::pow(C7*C12 - C8*C11, 2)) + - std::sqrt( std::pow(C5*C11 - C6*C10, 2) + std::pow(C5*C12 - C9*C10, 2) + std::pow(C6*C12 - C9*C11, 2)) + - std::sqrt( std::pow(C4*C14 - C7*C13, 2) + std::pow(C4*C15 - C8*C13, 2) + std::pow(C7*C15 - C8*C14, 2)) + - std::sqrt( std::pow(C5*C14 - C6*C13, 2) + std::pow(C5*C15 - C9*C13, 2) + std::pow(C6*C15 - C9*C14, 2)) - ); + // New - 24/01/2014 - Massimo Petracca + // the following procedure calculates the area of a general + // quadrilateral (flat or warped) using the parametric representation + // of ruled hyperbolic paraboloid surface. + // the integration of the normal is then performed with a 2x2 gauss quadrature + // in the U-V domain [0,1]. + // results explicitly written after symbolic calculation. + + const TPointType& p1 = this->Points()[0]; + const TPointType& p2 = this->Points()[1]; + const TPointType& p3 = this->Points()[2]; + const TPointType& p4 = this->Points()[3]; + + const double p1x = p1.X(); + const double p1y = p1.Y(); + const double p1z = p1.Z(); + + const double p2x = p2.X(); + const double p2y = p2.Y(); + const double p2z = p2.Z(); + + const double p3x = p3.X(); + const double p3y = p3.Y(); + const double p3z = p3.Z(); + + const double p4x = p4.X(); + const double p4y = p4.Y(); + const double p4z = p4.Z(); + + const double pos = 0.5 + 0.5 / std::sqrt(3.0); + const double w = 0.25; + + const double C1 = pos*(p1z - p2z + p3z - p4z); + const double C2 = pos*(p1y - p2y + p3y - p4y); + const double C3 = pos*(p1x - p2x + p3x - p4x); + const double C4 = C1 - p1z + p2z; + const double C5 = C1 + p1z - p2z; + const double C6 = C2 + p1y - p2y; + const double C7 = C2 - p1y + p2y; + const double C8 = C3 - p1x + p2x; + const double C9 = C3 + p1x - p2x; + const double C10 = C1 - p1z + p4z; + const double C11 = C2 - p1y + p4y; + const double C12 = C3 - p1x + p4x; + const double C13 = C1 + p1z - p4z; + const double C14 = C2 + p1y - p4y; + const double C15 = C3 + p1x - p4x; + + return w * ( + std::sqrt( std::pow(C4*C11 - C7*C10, 2) + std::pow(C4*C12 - C8*C10, 2) + std::pow(C7*C12 - C8*C11, 2)) + + std::sqrt( std::pow(C5*C11 - C6*C10, 2) + std::pow(C5*C12 - C9*C10, 2) + std::pow(C6*C12 - C9*C11, 2)) + + std::sqrt( std::pow(C4*C14 - C7*C13, 2) + std::pow(C4*C15 - C8*C13, 2) + std::pow(C7*C15 - C8*C14, 2)) + + std::sqrt( std::pow(C5*C14 - C6*C13, 2) + std::pow(C5*C15 - C9*C13, 2) + std::pow(C6*C15 - C9*C14, 2)) + ); } /** This method calculates and returns length, area or volume of @@ -497,7 +497,7 @@ template class Quadrilateral3D4 double Volume() const override { - // Old + // Old //Vector temp; //DeterminantOfJacobian( temp, msGeometryData.DefaultIntegrationMethod() ); @@ -512,30 +512,48 @@ template class Quadrilateral3D4 ////KRATOS_WATCH(temp) //return Volume; - // New - 24/01/2014 - Massimo Petracca + // New - 24/01/2014 - Massimo Petracca - return Area(); + return Area(); } - - - + /** - * Returns whether given arbitrary point is inside the Geometry - */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { PointLocalCoordinates( rResult, rPoint ); - if ( (rResult[0] >= (-1.0-Tolerance)) && (rResult[0] <= (1.0+Tolerance)) ) - if ( (rResult[1] >= (-1.0-Tolerance)) && (rResult[1] <= (1.0+Tolerance)) ) + if ( std::abs(rResult[0]) <= (1.0+Tolerance) ) + { + if ( std::abs(rResult[1]) <= (1.0+Tolerance) ) + { return true; + } + } return false; } - - - CoordinatesArrayType& PointLocalCoordinates( CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) override + + /** + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ + virtual CoordinatesArrayType& PointLocalCoordinates( + CoordinatesArrayType& rResult, + const CoordinatesArrayType& rPoint + ) override { boost::numeric::ublas::bounded_matrix X; boost::numeric::ublas::bounded_matrix DN; @@ -1370,8 +1388,6 @@ template class Quadrilateral3D4 return rResult; } - - /** * returns the shape function gradients in an arbitrary point, * given in local coordinates diff --git a/kratos/geometries/quadrilateral_3d_8.h b/kratos/geometries/quadrilateral_3d_8.h index ffc01d94cb37..b2bab85e18bb 100644 --- a/kratos/geometries/quadrilateral_3d_8.h +++ b/kratos/geometries/quadrilateral_3d_8.h @@ -408,8 +408,6 @@ template class Quadrilateral3D8 return Volume; } - - /** * This method calculates and returns length, area or volume of * this geometry depending to it's dimension. For one dimensional @@ -428,26 +426,48 @@ template class Quadrilateral3D8 { return fabs( DeterminantOfJacobian( PointType() ) ) * 0.5; } - + /** - * Returns whether given arbitrary point is inside the Geometry - */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { PointLocalCoordinates( rResult, rPoint ); if ( (rResult[0] >= (-1.0-Tolerance)) && (rResult[0] <= (1.0+Tolerance)) ) + { if ( (rResult[1] >= (-1.0-Tolerance)) && (rResult[1] <= (1.0+Tolerance)) ) + { return true; + } + } return false; } - CoordinatesArrayType& PointLocalCoordinates( CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) override + /** + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ + virtual CoordinatesArrayType& PointLocalCoordinates( + CoordinatesArrayType& rResult, + const CoordinatesArrayType& rPoint + ) override { - double tol = 1.0e-8; - int maxiter = 1000; + const double tol = 1.0e-8; + const int maxiter = 1000; + //check orientation of surface std::vector< unsigned int> orientation( 3 ); diff --git a/kratos/geometries/quadrilateral_3d_9.h b/kratos/geometries/quadrilateral_3d_9.h index fabcc3f1e618..a41f4827dae4 100644 --- a/kratos/geometries/quadrilateral_3d_9.h +++ b/kratos/geometries/quadrilateral_3d_9.h @@ -406,8 +406,6 @@ template class Quadrilateral3D9 : public Geometry return( sqrt( d[0]*d[0] + d[1]*d[1] + d[2]*d[2] ) ); } - - /** * :TODO: the charactereistic sizes have to be reviewed * by the one who is willing to use them! @@ -427,27 +425,47 @@ template class Quadrilateral3D9 : public Geometry { return fabs( DeterminantOfJacobian( PointType() ) ) * 0.5; } - + /** - * Returns whether given arbitrary point is inside the Geometry - */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { PointLocalCoordinates( rResult, rPoint ); - if ( fabs( rResult[0] ) <= (1.0 + Tolerance) ) - if ( fabs( rResult[1] ) <= (1.0 + Tolerance) ) + if ( std::abs( rResult[0] ) <= (1.0 + Tolerance) ) + { + if ( std::abs( rResult[1] ) <= (1.0 + Tolerance) ) + { return true; + } + } return false; } - - CoordinatesArrayType& PointLocalCoordinates( CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) override + /** + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ + virtual CoordinatesArrayType& PointLocalCoordinates( + CoordinatesArrayType& rResult, + const CoordinatesArrayType& rPoint + ) override { - double tol = 1.0e-8; - int maxiter = 1000; + const double tol = 1.0e-8; + const int maxiter = 1000; //check orientation of surface std::vector< unsigned int> orientation( 3 ); diff --git a/kratos/geometries/quadrilateral_interface_2d_4.h b/kratos/geometries/quadrilateral_interface_2d_4.h index 639314eaf79d..c6e9940386b8 100644 --- a/kratos/geometries/quadrilateral_interface_2d_4.h +++ b/kratos/geometries/quadrilateral_interface_2d_4.h @@ -45,7 +45,7 @@ namespace Kratos /** * A four node quadrilateral interface geometry. The shape functions are the same as for the - * quadrilateral_2d_4 element, but the jacobian is computed as in the line_2d_2 element to + * quadrilateral_2d_4 element, but the jacobian is computed as in the line_2d_2 element to * to avoid having detJ = 0. Default integration method is Lobatto. */ @@ -197,10 +197,10 @@ template class QuadrilateralInterface2D4 // double p2_p1_Y = (ThirdPoint->Y() + FourthPoint->Y() - FirstPoint->Y() - SecondPoint->Y())*0.5; // double p4_p3_X = (ThirdPoint->X() + SecondPoint->X() - FirstPoint->X() - FourthPoint->X())*0.5; // double p4_p3_Y = (ThirdPoint->Y() + SecondPoint->Y() - FirstPoint->Y() - FourthPoint->Y())*0.5; -// +// // double lx = std::sqrt(p4_p3_X*p4_p3_X + p4_p3_Y*p4_p3_Y); // double ly = std::sqrt(p2_p1_X*p2_p1_X + p2_p1_Y*p2_p1_Y); -// if(lx > ly) +// if(lx > ly) // { // this->Points().push_back( typename PointType::Pointer( new PointType( FirstPoint ) ) ); // this->Points().push_back( typename PointType::Pointer( new PointType( SecondPoint ) ) ); @@ -229,8 +229,8 @@ template class QuadrilateralInterface2D4 double lx = std::sqrt(p4_p3_X*p4_p3_X + p4_p3_Y*p4_p3_Y); double ly = std::sqrt(p2_p1_X*p2_p1_X + p2_p1_Y*p2_p1_Y); - - if(ly < lx) + + if(ly < lx) { this->Points().push_back( pFirstPoint ); this->Points().push_back( pSecondPoint ); @@ -289,12 +289,12 @@ template class QuadrilateralInterface2D4 */ virtual ~QuadrilateralInterface2D4() {} - GeometryData::KratosGeometryFamily GetGeometryFamily() + GeometryData::KratosGeometryFamily GetGeometryFamily() override { return GeometryData::Kratos_Quadrilateral; } - GeometryData::KratosGeometryType GetGeometryType() + GeometryData::KratosGeometryType GetGeometryType() override { return GeometryData::Kratos_Quadrilateral2D4; } @@ -342,12 +342,12 @@ template class QuadrilateralInterface2D4 ///@name Operations ///@{ - typename BaseType::Pointer Create( PointsArrayType const& ThisPoints ) const + typename BaseType::Pointer Create( PointsArrayType const& ThisPoints ) const override { return typename BaseType::Pointer( new QuadrilateralInterface2D4( ThisPoints ) ); } - - virtual Geometry< Point<3> >::Pointer Clone() const + + Geometry< Point<3> >::Pointer Clone() const override { Geometry< Point<3> >::PointsArrayType NewPoints; @@ -369,7 +369,7 @@ template class QuadrilateralInterface2D4 * @param rResult a Matrix object that will be overwritten by the result * @return the local coordinates of all nodes */ - virtual Matrix& PointsLocalCoordinates( Matrix& rResult ) const + Matrix& PointsLocalCoordinates( Matrix& rResult ) const override { noalias( rResult ) = ZeroMatrix( 4, 2 ); rResult( 0, 0 ) = -1.0; @@ -384,7 +384,7 @@ template class QuadrilateralInterface2D4 } //lumping factors for the calculation of the lumped mass matrix - virtual Vector& LumpingFactors( Vector& rResult ) const + Vector& LumpingFactors( Vector& rResult ) const override { if(rResult.size() != 4) rResult.resize( 4, false ); @@ -415,11 +415,11 @@ template class QuadrilateralInterface2D4 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - virtual double Length() const + double Length() const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 2 )); - + array_1d v( p1 - p0 ); return std::sqrt( v[0]*v[0] + v[1]*v[1] ); } @@ -439,7 +439,7 @@ template class QuadrilateralInterface2D4 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - virtual double Area() const + double Area() const override { return Length(); } @@ -459,32 +459,49 @@ template class QuadrilateralInterface2D4 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - virtual double DomainSize() const + double DomainSize() const override { return Length(); } /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - virtual bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) + bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if ( fabs(rResult[0]) <= (1.0+Tolerance) ) - if ( fabs(rResult[1]) <= (1.0+Tolerance) ) + if ( std::abs(rResult[0]) <= (1.0+Tolerance) ) + { + if ( std::abs(rResult[1]) <= (1.0+Tolerance) ) + { return true; + } + } return false; } /** - * Returns the local coordinates of a given arbitrary point - */ + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ // TODO: Check if correct - virtual CoordinatesArrayType& PointLocalCoordinates( - CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) + CoordinatesArrayType& PointLocalCoordinates( + CoordinatesArrayType& rResult, + const CoordinatesArrayType& rPoint + ) override { rResult.clear(); @@ -492,42 +509,42 @@ template class QuadrilateralInterface2D4 noalias(FirstPoint) = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d SecondPoint; noalias(SecondPoint) = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 2 )); - + // Project point double tol = 1e-14; // Tolerance - + // Normal array_1d Normal = ZeroVector(2); Normal[0] = SecondPoint[1] - FirstPoint[1]; Normal[1] = FirstPoint[0] - SecondPoint[0]; double norm = std::sqrt(Normal[0] * Normal[0] + Normal[1] * Normal[1]); Normal /= norm; - + // Vector point and distance array_1d VectorPoint = ZeroVector(2); VectorPoint[0] = rPoint[0] - FirstPoint[0]; VectorPoint[1] = rPoint[1] - FirstPoint[1]; double dist_proy = VectorPoint[0] * Normal[0] + VectorPoint[1] * Normal[1]; - + if (dist_proy < tol) { double L = Length(); - + double l1 = (rPoint[0] - FirstPoint[0]) * (rPoint[0] - FirstPoint[0]) + (rPoint[1] - FirstPoint[1]) * (rPoint[1] - FirstPoint[1]); l1 = std::sqrt(l1); - + double l2 = (rPoint[0] - SecondPoint[0]) * (rPoint[0] - SecondPoint[0]) + (rPoint[1] - SecondPoint[1]) * (rPoint[1] - SecondPoint[1]); l2 = std::sqrt(l2); - + // std::cout << "L: " << L << " l1: " << l1 << " l2: " << l2 << std::endl; if (l1 <= (L + tol) && l2 <= (L + tol)) { rResult[0] = 2.0 * l1/(L + tol) - 1.0; } - else + else { rResult[0] = 2.0; // Out of the line!!! TODO: Check if this value gives problems } @@ -561,9 +578,9 @@ template class QuadrilateralInterface2D4 * @see DeterminantOfJacobian * @see InverseOfJacobian */ - virtual Matrix& Jacobian( Matrix& rResult, - IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod ) const + Matrix& Jacobian( Matrix& rResult, + IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 2 )); @@ -594,21 +611,21 @@ template class QuadrilateralInterface2D4 @see DeterminantOfJacobian @see InverseOfJacobian */ - virtual Matrix& Jacobian( Matrix& rResult, - IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod, - Matrix& DeltaPosition ) const + Matrix& Jacobian( Matrix& rResult, + IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod, + Matrix& DeltaPosition ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 2 )); - + array_1d dp0; array_1d dp1; dp0[0] = (DeltaPosition(0,0) + DeltaPosition(3,0))*0.5; dp0[1] = (DeltaPosition(0,1) + DeltaPosition(3,1))*0.5; dp1[0] = (DeltaPosition(1,0) + DeltaPosition(2,0))*0.5; dp1[1] = (DeltaPosition(1,1) + DeltaPosition(2,1))*0.5; - + if(rResult.size1() != 2 || rResult.size2() != 1) rResult.resize(2, 1, false); rResult( 0, 0 ) = ( (p1[0]-dp1[0]) - (p0[0]-dp0[0]) ) * 0.5; @@ -632,7 +649,7 @@ template class QuadrilateralInterface2D4 * @see DeterminantOfJacobian * @see InverseOfJacobian */ - virtual Matrix& Jacobian( Matrix& rResult, const CoordinatesArrayType& rPoint ) const + Matrix& Jacobian( Matrix& rResult, const CoordinatesArrayType& rPoint ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 2 )); @@ -658,8 +675,8 @@ template class QuadrilateralInterface2D4 * @see Jacobian * @see InverseOfJacobian */ - virtual Vector& DeterminantOfJacobian( Vector& rResult, - IntegrationMethod ThisMethod ) const + Vector& DeterminantOfJacobian( Vector& rResult, + IntegrationMethod ThisMethod ) const override { //workaround by riccardo if ( rResult.size() != this->IntegrationPointsNumber( ThisMethod ) ) @@ -695,8 +712,8 @@ template class QuadrilateralInterface2D4 * @see Jacobian * @see InverseOfJacobian */ - virtual double DeterminantOfJacobian( IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod ) const + double DeterminantOfJacobian( IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod ) const override { return Length()*0.5; } @@ -726,7 +743,7 @@ template class QuadrilateralInterface2D4 * point in space this needs to be reviewed * (comment by janosch) */ - virtual double DeterminantOfJacobian( const CoordinatesArrayType& rPoint ) const + double DeterminantOfJacobian( const CoordinatesArrayType& rPoint ) const override { return Length()*0.5; } @@ -752,8 +769,8 @@ template class QuadrilateralInterface2D4 * * KLUDGE: works only with explicitly generated Matrix object */ - virtual JacobiansType& InverseOfJacobian( JacobiansType& rResult, - IntegrationMethod ThisMethod ) const + JacobiansType& InverseOfJacobian( JacobiansType& rResult, + IntegrationMethod ThisMethod ) const override { KRATOS_ERROR << "Jacobian is not square" << std::endl; return rResult; @@ -782,9 +799,9 @@ template class QuadrilateralInterface2D4 * * KLUDGE: works only with explicitly generated Matrix object */ - virtual Matrix& InverseOfJacobian( Matrix& rResult, - IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod ) const + Matrix& InverseOfJacobian( Matrix& rResult, + IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod ) const override { KRATOS_ERROR << "Jacobian is not square" << std::endl; return rResult; @@ -806,8 +823,8 @@ template class QuadrilateralInterface2D4 * * KLUDGE: works only with explicitly generated Matrix object */ - virtual Matrix& InverseOfJacobian( Matrix& rResult, - const CoordinatesArrayType& rPoint ) const + Matrix& InverseOfJacobian( Matrix& rResult, + const CoordinatesArrayType& rPoint ) const override { KRATOS_ERROR << "Jacobian is not square" << std::endl; return rResult; @@ -823,7 +840,7 @@ template class QuadrilateralInterface2D4 @see Edges() @see Edge() */ - virtual SizeType EdgesNumber() const + SizeType EdgesNumber() const override { return 4; } @@ -839,7 +856,7 @@ template class QuadrilateralInterface2D4 @see EdgesNumber() @see Edge() */ - virtual GeometriesArrayType Edges( void ) + GeometriesArrayType Edges( void ) override { GeometriesArrayType edges = GeometriesArrayType(); edges.push_back( boost::make_shared( this->pGetPoint( 0 ), this->pGetPoint( 1 ) ) ); @@ -865,8 +882,8 @@ template class QuadrilateralInterface2D4 * * @return the value of the shape function at the given point */ - virtual double ShapeFunctionValue( IndexType ShapeFunctionIndex, - const CoordinatesArrayType& rPoint ) const + double ShapeFunctionValue( IndexType ShapeFunctionIndex, + const CoordinatesArrayType& rPoint ) const override { switch ( ShapeFunctionIndex ) { @@ -896,14 +913,14 @@ template class QuadrilateralInterface2D4 @see ShapeFunctionsLocalGradients @see ShapeFunctionLocalGradient */ - virtual Vector& ShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType& rCoordinates) const + Vector& ShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType& rCoordinates) const override { if(rResult.size() != 4) rResult.resize(4,false); rResult[0] = 0.25*( 1.0 - rCoordinates[0] )*( 1.0 - rCoordinates[1] ); rResult[1] = 0.25*( 1.0 + rCoordinates[0] )*( 1.0 - rCoordinates[1] ); rResult[2] = 0.25*( 1.0 + rCoordinates[0] )*( 1.0 + rCoordinates[1] ); rResult[3] = 0.25*( 1.0 - rCoordinates[0] )*( 1.0 + rCoordinates[1] ); - + return rResult; } @@ -923,9 +940,9 @@ template class QuadrilateralInterface2D4 * KLUDGE: method call only works with explicit JacobiansType rather than creating * JacobiansType within argument list */ - virtual ShapeFunctionsGradientsType& ShapeFunctionsIntegrationPointsGradients( + ShapeFunctionsGradientsType& ShapeFunctionsIntegrationPointsGradients( ShapeFunctionsGradientsType& rResult, - IntegrationMethod ThisMethod ) const + IntegrationMethod ThisMethod ) const override { const unsigned int integration_points_number = msGeometryData.IntegrationPointsNumber( ThisMethod ); @@ -981,7 +998,7 @@ template class QuadrilateralInterface2D4 * @see PrintData() * @see PrintInfo() */ - virtual std::string Info() const + std::string Info() const override { return "2 dimensional quadrilateral with four nodes in 2D space"; } @@ -992,7 +1009,7 @@ template class QuadrilateralInterface2D4 * @see PrintData() * @see Info() */ - virtual void PrintInfo( std::ostream& rOStream ) const + void PrintInfo( std::ostream& rOStream ) const override { rOStream << "2 dimensional quadrilateral with four nodes in 2D space"; } @@ -1011,7 +1028,7 @@ template class QuadrilateralInterface2D4 * :TODO: needs to be reviewed because it is not properly implemented yet * (comment by janosch) */ - virtual void PrintData( std::ostream& rOStream ) const + void PrintData( std::ostream& rOStream ) const override { BaseType::PrintData( rOStream ); std::cout << std::endl; @@ -1020,48 +1037,6 @@ template class QuadrilateralInterface2D4 rOStream << " Jacobian in the origin\t : " << jacobian; } - /** - * Calculates the local gradients for all integration points for - * given integration method - */ - virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients( - IntegrationMethod ThisMethod ) - { - ShapeFunctionsGradientsType localGradients - = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod ); - const int integration_points_number - = msGeometryData.IntegrationPointsNumber( ThisMethod ); - ShapeFunctionsGradientsType Result( integration_points_number ); - - for ( int pnt = 0; pnt < integration_points_number; pnt++ ) - { - Result[pnt] = localGradients[pnt]; - } - - return Result; - } - - /** - * Calculates the local gradients for all integration points for the - * default integration method - */ - virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients() - { - IntegrationMethod ThisMethod = msGeometryData.DefaultIntegrationMethod(); - ShapeFunctionsGradientsType localGradients - = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod ); - const int integration_points_number - = msGeometryData.IntegrationPointsNumber( ThisMethod ); - ShapeFunctionsGradientsType Result( integration_points_number ); - - for ( int pnt = 0; pnt < integration_points_number; pnt++ ) - { - Result[pnt] = localGradients[pnt]; - } - - return Result; - } - /** * Calculates the gradients in terms of local coordinates * of all shape functions in a given point. @@ -1071,8 +1046,7 @@ template class QuadrilateralInterface2D4 * @return the gradients of all shape functions * \f$ \frac{\partial N^i}{\partial \xi_j} \f$ */ - virtual Matrix& ShapeFunctionsLocalGradients( Matrix& rResult, - const CoordinatesArrayType& rPoint ) const + Matrix& ShapeFunctionsLocalGradients( Matrix& rResult, const CoordinatesArrayType& rPoint ) const override { rResult.resize( 4, 2 ,false); noalias( rResult ) = ZeroMatrix( 4, 2 ); @@ -1087,38 +1061,14 @@ template class QuadrilateralInterface2D4 return rResult; } - - - /** - * returns the shape function gradients in an arbitrary point, - * given in local coordinates - * - * @param rResult the matrix of gradients, - * will be overwritten with the gradients for all - * shape functions in given point - * @param rPoint the given point the gradients are calculated in - */ - virtual Matrix& ShapeFunctionsGradients( Matrix& rResult, PointType& rPoint ) - { - rResult.resize( 4, 2 ,false); - rResult( 0, 0 ) = -0.25 * ( 1.0 - rPoint.Y() ); - rResult( 0, 1 ) = -0.25 * ( 1.0 - rPoint.X() ); - rResult( 1, 0 ) = 0.25 * ( 1.0 - rPoint.Y() ); - rResult( 1, 1 ) = -0.25 * ( 1.0 + rPoint.X() ); - rResult( 2, 0 ) = 0.25 * ( 1.0 + rPoint.Y() ); - rResult( 2, 1 ) = 0.25 * ( 1.0 + rPoint.X() ); - rResult( 3, 0 ) = -0.25 * ( 1.0 + rPoint.Y() ); - rResult( 3, 1 ) = 0.25 * ( 1.0 - rPoint.X() ); - return rResult; - } - /** * returns the second order derivatives of all shape functions * in given arbitrary pointers * @param rResult a third order tensor which contains the second derivatives * @param rPoint the given point the second order derivatives are calculated in */ - virtual ShapeFunctionsSecondDerivativesType& ShapeFunctionsSecondDerivatives( ShapeFunctionsSecondDerivativesType& rResult, const CoordinatesArrayType& rPoint ) const + ShapeFunctionsSecondDerivativesType& ShapeFunctionsSecondDerivatives( ShapeFunctionsSecondDerivativesType& rResult, + const CoordinatesArrayType& rPoint ) const override { if ( rResult.size() != this->PointsNumber() ) { @@ -1158,7 +1108,8 @@ template class QuadrilateralInterface2D4 * @param rResult a fourth order tensor which contains the third derivatives * @param rPoint the given point the third order derivatives are calculated in */ - virtual ShapeFunctionsThirdDerivativesType& ShapeFunctionsThirdDerivatives( ShapeFunctionsThirdDerivativesType& rResult, const CoordinatesArrayType& rPoint ) const + ShapeFunctionsThirdDerivativesType& ShapeFunctionsThirdDerivatives( ShapeFunctionsThirdDerivativesType& rResult, + const CoordinatesArrayType& rPoint ) const override { if ( rResult.size() != this->PointsNumber() ) { @@ -1235,12 +1186,12 @@ template class QuadrilateralInterface2D4 friend class Serializer; - virtual void save( Serializer& rSerializer ) const + void save( Serializer& rSerializer ) const override { KRATOS_SERIALIZE_SAVE_BASE_CLASS( rSerializer, BaseType ); } - virtual void load( Serializer& rSerializer ) + void load( Serializer& rSerializer ) override { KRATOS_SERIALIZE_LOAD_BASE_CLASS( rSerializer, BaseType ); } @@ -1312,8 +1263,7 @@ template class QuadrilateralInterface2D4 * @return the vector of the gradients of all shape functions * in each integration point */ - static ShapeFunctionsGradientsType - CalculateShapeFunctionsIntegrationPointsLocalGradients( + static ShapeFunctionsGradientsType CalculateShapeFunctionsIntegrationPointsLocalGradients( typename BaseType::IntegrationMethod ThisMethod ) { IntegrationPointsContainerType all_integration_points = @@ -1353,7 +1303,7 @@ template class QuadrilateralInterface2D4 { Quadrature < QuadrilateralGaussLobattoIntegrationPoints1, 2, IntegrationPoint<3> >::GenerateIntegrationPoints(), - Quadrature < QuadrilateralGaussLobattoIntegrationPoints2, + Quadrature < QuadrilateralGaussLobattoIntegrationPoints2, 2, IntegrationPoint<3> >::GenerateIntegrationPoints(), IntegrationPointsArrayType(), IntegrationPointsArrayType() @@ -1462,5 +1412,4 @@ GeometryData QuadrilateralInterface2D4::msGeometryData( ); }// namespace Kratos. -#endif // KRATOS_QUADRILATERAL_INTERFACE_2D_4_H_INCLUDED defined - +#endif // KRATOS_QUADRILATERAL_INTERFACE_2D_4_H_INCLUDED defined diff --git a/kratos/geometries/quadrilateral_interface_3d_4.h b/kratos/geometries/quadrilateral_interface_3d_4.h index 9dd906487185..51d8298d1ca9 100644 --- a/kratos/geometries/quadrilateral_interface_3d_4.h +++ b/kratos/geometries/quadrilateral_interface_3d_4.h @@ -45,7 +45,7 @@ namespace Kratos /** * A four node quadrilateral interface geometry. The shape functions are the same as for the - * quadrilateral_3d_4 element, but the jacobian is computed as in the line_3d_2 element. + * quadrilateral_3d_4 element, but the jacobian is computed as in the line_3d_2 element. * Default integration method is Lobatto. */ @@ -198,16 +198,16 @@ template class QuadrilateralInterface3D4 // vx.clear(); // vx = SecondPoint + ThirdPoint - FirstPoint - FourthPoint; // vx *= 0.5; -// +// // array_1d< double , 3 > vy; // vy.clear(); // vy = ThirdPoint + FourthPoint - FirstPoint - SecondPoint; // vy *= 0.5; -// +// // double lx = MathUtils::Norm3(vx); // double ly = MathUtils::Norm3(vy); -// -// if(lx > ly) +// +// if(lx > ly) // { // this->Points().push_back( typename PointType::Pointer( new PointType( FirstPoint ) ) ); // this->Points().push_back( typename PointType::Pointer( new PointType( SecondPoint ) ) ); @@ -234,11 +234,11 @@ template class QuadrilateralInterface3D4 array_1d< double , 3 > vy; noalias(vy) = (*pThirdPoint + *pFourthPoint - *pFirstPoint - *pSecondPoint)*0.5; - + double lx = MathUtils::Norm3(vx); double ly = MathUtils::Norm3(vy); - - if(ly < lx) + + if(ly < lx) { this->Points().push_back( pFirstPoint ); this->Points().push_back( pSecondPoint ); @@ -297,12 +297,12 @@ template class QuadrilateralInterface3D4 */ virtual ~QuadrilateralInterface3D4() {} - GeometryData::KratosGeometryFamily GetGeometryFamily() + GeometryData::KratosGeometryFamily GetGeometryFamily() override { return GeometryData::Kratos_Quadrilateral; } - GeometryData::KratosGeometryType GetGeometryType() + GeometryData::KratosGeometryType GetGeometryType() override { return GeometryData::Kratos_Quadrilateral3D4; } @@ -350,12 +350,12 @@ template class QuadrilateralInterface3D4 ///@name Operations ///@{ - typename BaseType::Pointer Create( PointsArrayType const& ThisPoints ) const + typename BaseType::Pointer Create( PointsArrayType const& ThisPoints ) const override { return typename BaseType::Pointer( new QuadrilateralInterface3D4( ThisPoints ) ); } - virtual Geometry< Point<3> >::Pointer Clone() const + Geometry< Point<3> >::Pointer Clone() const override { Geometry< Point<3> >::PointsArrayType NewPoints; @@ -377,7 +377,7 @@ template class QuadrilateralInterface3D4 * @param rResult a Matrix object that will be overwritten by the result * @return the local coordinates of all nodes */ - virtual Matrix& PointsLocalCoordinates( Matrix& rResult ) const + Matrix& PointsLocalCoordinates( Matrix& rResult ) const override { noalias( rResult ) = ZeroMatrix( 4, 2 ); rResult( 0, 0 ) = -1.0; @@ -392,7 +392,7 @@ template class QuadrilateralInterface3D4 } //lumping factors for the calculation of the lumped mass matrix - virtual Vector& LumpingFactors( Vector& rResult ) const + Vector& LumpingFactors( Vector& rResult ) const override { if(rResult.size() != 4) rResult.resize( 4, false ); @@ -423,13 +423,13 @@ template class QuadrilateralInterface3D4 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - virtual double Length() const + double Length() const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 2 )); - + array_1d vx( p1 - p0 ); - + return MathUtils::Norm3(vx); } @@ -448,7 +448,7 @@ template class QuadrilateralInterface3D4 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - virtual double Area() const + double Area() const override { return Length(); } @@ -467,34 +467,54 @@ template class QuadrilateralInterface3D4 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - virtual double DomainSize() const + double DomainSize() const override { return Area(); } - virtual double Volume() const + double Volume() const override { return Area(); } /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - virtual bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) + bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { PointLocalCoordinates( rResult, rPoint ); if ( (rResult[0] >= (-1.0 - Tolerance)) && (rResult[0] <= (1.0 + Tolerance)) ) + { if ( (rResult[1] >= (-1.0 - Tolerance)) && (rResult[1] <= (1.0 + Tolerance)) ) + { return true; + } + } return false; } - - virtual CoordinatesArrayType& PointLocalCoordinates( CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) + /** + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ + CoordinatesArrayType& PointLocalCoordinates( + CoordinatesArrayType& rResult, + const CoordinatesArrayType& rPoint + ) override { boost::numeric::ublas::bounded_matrix X; boost::numeric::ublas::bounded_matrix DN; @@ -582,14 +602,14 @@ template class QuadrilateralInterface3D4 * point index of given integration method. * * @param DeltaPosition Matrix with the nodes position increment which describes - * the configuration where the jacobian has to be calculated. + * the configuration where the jacobian has to be calculated. * * @see DeterminantOfJacobian * @see InverseOfJacobian */ - virtual JacobiansType& Jacobian( JacobiansType& rResult, - IntegrationMethod ThisMethod, - Matrix & DeltaPosition ) const + JacobiansType& Jacobian( JacobiansType& rResult, + IntegrationMethod ThisMethod, + Matrix & DeltaPosition ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 2 )); @@ -602,7 +622,7 @@ template class QuadrilateralInterface3D4 dp1[0] = (DeltaPosition(1,0) + DeltaPosition(2,0))*0.5; dp1[1] = (DeltaPosition(1,1) + DeltaPosition(2,1))*0.5; dp1[2] = (DeltaPosition(1,2) + DeltaPosition(2,2))*0.5; - + Matrix jacobian( 3, 1 ); jacobian( 0, 0 ) = ( p1[0]-dp1[0] - (p0[0]-dp0[0]) ) * 0.5; //on the Gauss points (J is constant at each element) jacobian( 1, 0 ) = ( p1[1]-dp1[1] - (p0[1]-dp0[1]) ) * 0.5; @@ -640,20 +660,20 @@ template class QuadrilateralInterface3D4 * @see DeterminantOfJacobian * @see InverseOfJacobian */ - virtual Matrix& Jacobian( Matrix& rResult, - IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod ) const + Matrix& Jacobian( Matrix& rResult, + IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 2 )); - + if(rResult.size1() != 3 || rResult.size2() != 1) rResult.resize(3, 1, false); - + rResult( 0, 0 ) = ( p1[0] - p0[0] ) * 0.5; rResult( 1, 0 ) = ( p1[1] - p0[1] ) * 0.5; rResult( 2, 0 ) = ( p1[2] - p0[2] ) * 0.5; - + return rResult; } @@ -672,18 +692,18 @@ template class QuadrilateralInterface3D4 * @see DeterminantOfJacobian * @see InverseOfJacobian */ - virtual Matrix& Jacobian( Matrix& rResult, const CoordinatesArrayType& rPoint ) const + Matrix& Jacobian( Matrix& rResult, const CoordinatesArrayType& rPoint ) const override { array_1d p0 = 0.5 * (BaseType::GetPoint( 0 ) + BaseType::GetPoint( 3 )); array_1d p1 = 0.5 * (BaseType::GetPoint( 1 ) + BaseType::GetPoint( 2 )); - + if(rResult.size1() != 3 || rResult.size2() != 1) rResult.resize(3, 1, false); - + rResult( 0, 0 ) = ( p1[0] - p0[0] ) * 0.5; rResult( 1, 0 ) = ( p1[1] - p0[1] ) * 0.5; rResult( 2, 0 ) = ( p1[2] - p0[2] ) * 0.5; - + return rResult; } @@ -702,8 +722,8 @@ template class QuadrilateralInterface3D4 * @see Jacobian * @see InverseOfJacobian */ - virtual Vector& DeterminantOfJacobian( Vector& rResult, - IntegrationMethod ThisMethod ) const + Vector& DeterminantOfJacobian( Vector& rResult, + IntegrationMethod ThisMethod ) const override { KRATOS_ERROR << "QuadrilateralInterface3D4::DeterminantOfJacobian" <<"Jacobian is not square" << std::endl; return rResult; @@ -731,8 +751,8 @@ template class QuadrilateralInterface3D4 * @see Jacobian * @see InverseOfJacobian */ - virtual double DeterminantOfJacobian( IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod ) const + double DeterminantOfJacobian( IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod ) const override { KRATOS_ERROR << "QuadrilateralInterface3D4::DeterminantOfJacobian" << "Jacobian is not square" << std::endl; return 0.0; @@ -763,7 +783,7 @@ template class QuadrilateralInterface3D4 * point in space this needs to be reviewed * (comment by janosch) */ - virtual double DeterminantOfJacobian( const CoordinatesArrayType& rPoint ) const + double DeterminantOfJacobian( const CoordinatesArrayType& rPoint ) const override { KRATOS_ERROR << "QuadrilateralInterface3D4::DeterminantOfJacobian" << "Jacobian is not square" << std::endl; return 0.0; @@ -790,8 +810,8 @@ template class QuadrilateralInterface3D4 * * KLUDGE: works only with explicitly generated Matrix object */ - virtual JacobiansType& InverseOfJacobian( JacobiansType& rResult, - IntegrationMethod ThisMethod ) const + JacobiansType& InverseOfJacobian( JacobiansType& rResult, + IntegrationMethod ThisMethod ) const override { KRATOS_ERROR << "QuadrilateralInterface3D4::DeterminantOfJacobian" << "Jacobian is not square" << std::endl; return rResult; @@ -820,9 +840,9 @@ template class QuadrilateralInterface3D4 * * KLUDGE: works only with explicitly generated Matrix object */ - virtual Matrix& InverseOfJacobian( Matrix& rResult, - IndexType IntegrationPointIndex, - IntegrationMethod ThisMethod ) const + Matrix& InverseOfJacobian( Matrix& rResult, + IndexType IntegrationPointIndex, + IntegrationMethod ThisMethod ) const override { KRATOS_ERROR << "QuadrilateralInterface3D4::DeterminantOfJacobian" << "Jacobian is not square" << std::endl; return rResult; @@ -844,8 +864,8 @@ template class QuadrilateralInterface3D4 * * KLUDGE: works only with explicitly generated Matrix object */ - virtual Matrix& InverseOfJacobian( Matrix& rResult, - const CoordinatesArrayType& rPoint ) const + Matrix& InverseOfJacobian( Matrix& rResult, + const CoordinatesArrayType& rPoint ) const override { KRATOS_ERROR << "QuadrilateralInterface3D4::DeterminantOfJacobian" << "Jacobian is not square" << std::endl; return rResult; @@ -861,7 +881,7 @@ template class QuadrilateralInterface3D4 @see Edges() @see Edge() */ - virtual SizeType EdgesNumber() const + SizeType EdgesNumber() const override { return 4; } @@ -877,7 +897,7 @@ template class QuadrilateralInterface3D4 @see EdgesNumber() @see Edge() */ - virtual GeometriesArrayType Edges( void ) + GeometriesArrayType Edges( void ) override { GeometriesArrayType edges = GeometriesArrayType(); typedef typename Geometry::Pointer EdgePointerType; @@ -904,8 +924,8 @@ template class QuadrilateralInterface3D4 * * @return the value of the shape function at the given point */ - virtual double ShapeFunctionValue( IndexType ShapeFunctionIndex, - const CoordinatesArrayType& rPoint ) const + double ShapeFunctionValue( IndexType ShapeFunctionIndex, + const CoordinatesArrayType& rPoint ) const override { switch ( ShapeFunctionIndex ) { @@ -935,14 +955,14 @@ template class QuadrilateralInterface3D4 @see ShapeFunctionsLocalGradients @see ShapeFunctionLocalGradient */ - virtual Vector& ShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType& rCoordinates) const + Vector& ShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType& rCoordinates) const override { if(rResult.size() != 4) rResult.resize(4,false); rResult[0] = 0.25*( 1.0 - rCoordinates[0] )*( 1.0 - rCoordinates[1] ); rResult[1] = 0.25*( 1.0 + rCoordinates[0] )*( 1.0 - rCoordinates[1] ); rResult[2] = 0.25*( 1.0 + rCoordinates[0] )*( 1.0 + rCoordinates[1] ); rResult[3] = 0.25*( 1.0 - rCoordinates[0] )*( 1.0 + rCoordinates[1] ); - + return rResult; } @@ -962,9 +982,9 @@ template class QuadrilateralInterface3D4 * KLUDGE: method call only works with explicit JacobiansType rather than creating * JacobiansType within argument list */ - virtual ShapeFunctionsGradientsType& ShapeFunctionsIntegrationPointsGradients( + ShapeFunctionsGradientsType& ShapeFunctionsIntegrationPointsGradients( ShapeFunctionsGradientsType& rResult, - IntegrationMethod ThisMethod ) const + IntegrationMethod ThisMethod ) const override { const unsigned int integration_points_number = msGeometryData.IntegrationPointsNumber( ThisMethod ); @@ -1020,7 +1040,7 @@ template class QuadrilateralInterface3D4 * @see PrintData() * @see PrintInfo() */ - virtual std::string Info() const + std::string Info() const override { return "3 dimensional quadrilateral with four nodes in 3D space"; } @@ -1031,7 +1051,7 @@ template class QuadrilateralInterface3D4 * @see PrintData() * @see Info() */ - virtual void PrintInfo( std::ostream& rOStream ) const + void PrintInfo( std::ostream& rOStream ) const override { rOStream << "3 dimensional quadrilateral with four nodes in 3D space"; } @@ -1050,7 +1070,7 @@ template class QuadrilateralInterface3D4 * :TODO: needs to be reviewed because it is not properly implemented yet * (comment by janosch) */ - virtual void PrintData( std::ostream& rOStream ) const + void PrintData( std::ostream& rOStream ) const override { BaseType::PrintData( rOStream ); std::cout << std::endl; @@ -1059,48 +1079,6 @@ template class QuadrilateralInterface3D4 rOStream << " Jacobian in the origin\t : " << jacobian; } - /** - * Calculates the local gradients for all integration points for - * given integration method - */ - virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients( - IntegrationMethod ThisMethod ) - { - ShapeFunctionsGradientsType localGradients - = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod ); - const int integration_points_number - = msGeometryData.IntegrationPointsNumber( ThisMethod ); - ShapeFunctionsGradientsType Result( integration_points_number ); - - for ( int pnt = 0; pnt < integration_points_number; pnt++ ) - { - Result[pnt] = localGradients[pnt]; - } - - return Result; - } - - /** - * Calculates the local gradients for all integration points for the - * default integration method - */ - virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients() - { - IntegrationMethod ThisMethod = msGeometryData.DefaultIntegrationMethod(); - ShapeFunctionsGradientsType localGradients - = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod ); - const int integration_points_number - = msGeometryData.IntegrationPointsNumber( ThisMethod ); - ShapeFunctionsGradientsType Result( integration_points_number ); - - for ( int pnt = 0; pnt < integration_points_number; pnt++ ) - { - Result[pnt] = localGradients[pnt]; - } - - return Result; - } - /** * Calculates the gradients in terms of local coordinates * of all shape functions in a given point. @@ -1110,8 +1088,8 @@ template class QuadrilateralInterface3D4 * @return the gradients of all shape functions * \f$ \frac{\partial N^i}{\partial \xi_j} \f$ */ - virtual Matrix& ShapeFunctionsLocalGradients( Matrix& rResult, - const CoordinatesArrayType& rPoint ) const + Matrix& ShapeFunctionsLocalGradients( Matrix& rResult, + const CoordinatesArrayType& rPoint ) const override { rResult.resize( 4, 2, false ); noalias( rResult ) = ZeroMatrix( 4, 2 ); @@ -1126,38 +1104,14 @@ template class QuadrilateralInterface3D4 return rResult; } - - - /** - * returns the shape function gradients in an arbitrary point, - * given in local coordinates - * - * @param rResult the matrix of gradients, - * will be overwritten with the gradients for all - * shape functions in given point - * @param rPoint the given point the gradients are calculated in - */ - virtual Matrix& ShapeFunctionsGradients( Matrix& rResult, PointType& rPoint ) - { - rResult.resize( 4, 2, false ); - rResult( 0, 0 ) = -0.25 * ( 1.0 - rPoint.Y() ); - rResult( 0, 1 ) = -0.25 * ( 1.0 - rPoint.X() ); - rResult( 1, 0 ) = 0.25 * ( 1.0 - rPoint.Y() ); - rResult( 1, 1 ) = -0.25 * ( 1.0 + rPoint.X() ); - rResult( 2, 0 ) = 0.25 * ( 1.0 + rPoint.Y() ); - rResult( 2, 1 ) = 0.25 * ( 1.0 + rPoint.X() ); - rResult( 3, 0 ) = -0.25 * ( 1.0 + rPoint.Y() ); - rResult( 3, 1 ) = 0.25 * ( 1.0 - rPoint.X() ); - return rResult; - } - /** * returns the second order derivatives of all shape functions * in given arbitrary pointers * @param rResult a third order tensor which contains the second derivatives * @param rPoint the given point the second order derivatives are calculated in */ - virtual ShapeFunctionsSecondDerivativesType& ShapeFunctionsSecondDerivatives( ShapeFunctionsSecondDerivativesType& rResult, const CoordinatesArrayType& rPoint ) const + ShapeFunctionsSecondDerivativesType& ShapeFunctionsSecondDerivatives( ShapeFunctionsSecondDerivativesType& rResult, + const CoordinatesArrayType& rPoint ) const override { if ( rResult.size() != this->PointsNumber() ) { @@ -1197,7 +1151,8 @@ template class QuadrilateralInterface3D4 * @param rResult a fourth order tensor which contains the third derivatives * @param rPoint the given point the third order derivatives are calculated in */ - virtual ShapeFunctionsThirdDerivativesType& ShapeFunctionsThirdDerivatives( ShapeFunctionsThirdDerivativesType& rResult, const CoordinatesArrayType& rPoint ) const + ShapeFunctionsThirdDerivativesType& ShapeFunctionsThirdDerivatives( ShapeFunctionsThirdDerivativesType& rResult, + const CoordinatesArrayType& rPoint ) const override { if ( rResult.size() != this->PointsNumber() ) { @@ -1263,12 +1218,12 @@ template class QuadrilateralInterface3D4 friend class Serializer; - virtual void save( Serializer& rSerializer ) const + void save( Serializer& rSerializer ) const override { KRATOS_SERIALIZE_SAVE_BASE_CLASS( rSerializer, BaseType ); } - virtual void load( Serializer& rSerializer ) + void load( Serializer& rSerializer ) override { KRATOS_SERIALIZE_LOAD_BASE_CLASS( rSerializer, BaseType ); } @@ -1345,8 +1300,7 @@ template class QuadrilateralInterface3D4 * @return the vector of the gradients of all shape functions * in each integration point */ - static ShapeFunctionsGradientsType - CalculateShapeFunctionsIntegrationPointsLocalGradients( + static ShapeFunctionsGradientsType CalculateShapeFunctionsIntegrationPointsLocalGradients( typename BaseType::IntegrationMethod ThisMethod ) { IntegrationPointsContainerType all_integration_points = @@ -1387,7 +1341,7 @@ template class QuadrilateralInterface3D4 { Quadrature < QuadrilateralGaussLobattoIntegrationPoints1, 2, IntegrationPoint<3> >::GenerateIntegrationPoints(), - Quadrature < QuadrilateralGaussLobattoIntegrationPoints2, + Quadrature < QuadrilateralGaussLobattoIntegrationPoints2, 2, IntegrationPoint<3> >::GenerateIntegrationPoints(), IntegrationPointsArrayType(), IntegrationPointsArrayType() @@ -1496,4 +1450,4 @@ GeometryData QuadrilateralInterface3D4::msGeometryData( ); }// namespace Kratos. -#endif // KRATOS_QUADRILATERAL_INTERFACE_3D_4_H_INCLUDED defined +#endif // KRATOS_QUADRILATERAL_INTERFACE_3D_4_H_INCLUDED defined diff --git a/kratos/geometries/tetrahedra_3d_10.h b/kratos/geometries/tetrahedra_3d_10.h index ad55d7139b6c..8d503fd0f302 100644 --- a/kratos/geometries/tetrahedra_3d_10.h +++ b/kratos/geometries/tetrahedra_3d_10.h @@ -417,16 +417,35 @@ template class Tetrahedra3D10 : public Geometry return Volume(); } - - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + /** + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); if ( (rResult[0] >= (0.0 - Tolerance)) && (rResult[0] <= (1.0 + Tolerance)) ) + { if ( (rResult[1] >= (0.0 - Tolerance)) && (rResult[1] <= (1.0 + Tolerance)) ) + { if ( (rResult[2] >= (0.0 - Tolerance)) && (rResult[2] <= (1.0 + Tolerance)) ) + { if ((( 1.0 - ( rResult[0] + rResult[1] + rResult[2] ) ) >= (0.0 - Tolerance) ) && (( 1.0 - ( rResult[0] + rResult[1] + rResult[2] ) ) <= (1.0 + Tolerance) ) ) + { return true; + } + } + } + } return false; } diff --git a/kratos/geometries/tetrahedra_3d_4.h b/kratos/geometries/tetrahedra_3d_4.h index 12f3952235da..072c0f43d984 100644 --- a/kratos/geometries/tetrahedra_3d_4.h +++ b/kratos/geometries/tetrahedra_3d_4.h @@ -759,16 +759,35 @@ template class Tetrahedra3D4 : public Geometry } /** - * Returns whether given arbitrary point is inside the Geometry - */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); + if( rResult[0] >= 0.0-Tolerance ) + { if( rResult[1] >= 0.0-Tolerance ) + { if( rResult[2] >= 0.0-Tolerance ) + { if( (rResult[0] + rResult[1] + rResult[2]) <= (1.0+Tolerance)) + { return true; + } + } + } + } + return false; } diff --git a/kratos/geometries/triangle_2d_3.h b/kratos/geometries/triangle_2d_3.h index ab7faac5cfa3..343a655c6af6 100644 --- a/kratos/geometries/triangle_2d_3.h +++ b/kratos/geometries/triangle_2d_3.h @@ -676,17 +676,32 @@ template class Triangle2D3 return normFactor * (Area() * 2 / base ) / std::sqrt(sa+sb+sc); } - /** - * Returns whether given arbitrary point is inside the Geometry - */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if( rResult[0] >= (0.0-Tolerance) ) - if( rResult[1] >= (0.0-Tolerance) ) - if( (rResult[0] + rResult[1]) <= (1.0+Tolerance) ) + + if ( (rResult[0] >= (0.0-Tolerance)) && (rResult[0] <= (1.0+Tolerance)) ) + { + if ( (rResult[1] >= (0.0-Tolerance)) && (rResult[1] <= (1.0+Tolerance)) ) + { + if ( (rResult[0] + rResult[1]) <= (1.0+Tolerance) ) + { return true; + } + } + } return false; } diff --git a/kratos/geometries/triangle_2d_6.h b/kratos/geometries/triangle_2d_6.h index 99151d79bea4..457f1159ef80 100644 --- a/kratos/geometries/triangle_2d_6.h +++ b/kratos/geometries/triangle_2d_6.h @@ -457,21 +457,35 @@ template class Triangle2D6 } /** - * Returns whether given arbitrary point is inside the Geometry + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); - if ( (rResult[0] >= (0.0 - Tolerance)) && (rResult[0] <= (1.0 + Tolerance)) ) - if ( (rResult[1] >= (0.0 - Tolerance)) && (rResult[1] <= (1.0 + Tolerance)) ) - if ( (rResult[0] + rResult[1]) <= (1.0 + Tolerance) ) + if ( (rResult[0] >= (0.0-Tolerance)) && (rResult[0] <= (1.0+Tolerance)) ) + { + if ( (rResult[1] >= (0.0-Tolerance)) && (rResult[1] <= (1.0+Tolerance)) ) + { + if ( (rResult[0] + rResult[1]) <= (1.0+Tolerance) ) + { return true; + } + } + } return false; } - ///@} ///@name Shape Function ///@{ diff --git a/kratos/geometries/triangle_3d_3.h b/kratos/geometries/triangle_3d_3.h index 71347687418b..e7f9c6c59ebd 100644 --- a/kratos/geometries/triangle_3d_3.h +++ b/kratos/geometries/triangle_3d_3.h @@ -380,8 +380,9 @@ template class Triangle3D3 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - double Length() const override { - return std::sqrt(2.0 * Area()); + double Length() const override + { + return std::sqrt(2.0 * Area()); } /** This method calculates and returns area or surface area of @@ -399,14 +400,15 @@ template class Triangle3D3 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - double Area() const override { - double a = MathUtils::Norm3(this->GetPoint(0)-this->GetPoint(1)); - double b = MathUtils::Norm3(this->GetPoint(1)-this->GetPoint(2)); - double c = MathUtils::Norm3(this->GetPoint(2)-this->GetPoint(0)); + double Area() const override + { + const double a = MathUtils::Norm3(this->GetPoint(0)-this->GetPoint(1)); + const double b = MathUtils::Norm3(this->GetPoint(1)-this->GetPoint(2)); + const double c = MathUtils::Norm3(this->GetPoint(2)-this->GetPoint(0)); - double s = (a+b+c) / 2.0; + const double s = (a+b+c) / 2.0; - return std::sqrt(s*(s-a)*(s-b)*(s-c)); + return std::sqrt(s*(s-a)*(s-b)*(s-c)); } /** This method calculates and returns length, area or volume of @@ -423,8 +425,9 @@ template class Triangle3D3 * :TODO: could be replaced by something more suitable * (comment by janosch) */ - double DomainSize() const override { - return Area(); + double DomainSize() const override + { + return Area(); } /// Class Interface @@ -437,16 +440,17 @@ template class Triangle3D3 * @see MaxEdgeLength() * @see AverageEdgeLength() */ - double MinEdgeLength() const override { - auto a = this->GetPoint(0) - this->GetPoint(1); - auto b = this->GetPoint(1) - this->GetPoint(2); - auto c = this->GetPoint(2) - this->GetPoint(0); + double MinEdgeLength() const override + { + const array_1d a = this->GetPoint(0) - this->GetPoint(1); + const array_1d b = this->GetPoint(1) - this->GetPoint(2); + const array_1d c = this->GetPoint(2) - this->GetPoint(0); - auto sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); - auto sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); - auto sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); + const double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); + const double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); + const double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); - return CalculateMinEdgeLength(sa, sb, sc); + return CalculateMinEdgeLength(sa, sb, sc); } /** This method calculates and returns the maximum edge @@ -457,16 +461,17 @@ template class Triangle3D3 * @see MinEdgeLength() * @see AverageEdgeLength() */ - double MaxEdgeLength() const override { - auto a = this->GetPoint(0) - this->GetPoint(1); - auto b = this->GetPoint(1) - this->GetPoint(2); - auto c = this->GetPoint(2) - this->GetPoint(0); + double MaxEdgeLength() const override + { + const array_1d a = this->GetPoint(0) - this->GetPoint(1); + const array_1d b = this->GetPoint(1) - this->GetPoint(2); + const array_1d c = this->GetPoint(2) - this->GetPoint(0); - auto sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); - auto sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); - auto sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); + const double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); + const double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); + const double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); - return CalculateMaxEdgeLength(sa, sb, sc); + return CalculateMaxEdgeLength(sa, sb, sc); } /** This method calculates and returns the average edge @@ -477,12 +482,13 @@ template class Triangle3D3 * @see MinEdgeLength() * @see MaxEdgeLength() */ - double AverageEdgeLength() const override { - return CalculateAvgEdgeLength( + double AverageEdgeLength() const override + { + return CalculateAvgEdgeLength( MathUtils::Norm3(this->GetPoint(0)-this->GetPoint(1)), MathUtils::Norm3(this->GetPoint(1)-this->GetPoint(2)), MathUtils::Norm3(this->GetPoint(2)-this->GetPoint(0)) - ); + ); } /** Calculates the circumradius of the geometry. @@ -492,12 +498,13 @@ template class Triangle3D3 * * @see Inradius() */ - double Circumradius() const override { - return CalculateCircumradius( + double Circumradius() const override + { + return CalculateCircumradius( MathUtils::Norm3(this->GetPoint(0)-this->GetPoint(1)), MathUtils::Norm3(this->GetPoint(1)-this->GetPoint(2)), MathUtils::Norm3(this->GetPoint(2)-this->GetPoint(0)) - ); + ); } /** Calculates the inradius of the geometry. @@ -507,112 +514,117 @@ template class Triangle3D3 * * @see Circumradius() */ - double Inradius() const override { - return CalculateInradius( + double Inradius() const override + { + return CalculateInradius( MathUtils::Norm3(this->GetPoint(0)-this->GetPoint(1)), MathUtils::Norm3(this->GetPoint(1)-this->GetPoint(2)), MathUtils::Norm3(this->GetPoint(2)-this->GetPoint(0)) - ); + ); } - bool AllSameSide(array_1d const& Distances) { - constexpr double epsilon = std::numeric_limits::epsilon(); - // put U0,U1,U2 into plane equation 1 to compute signed distances to the plane// - double du0 = Distances[0]; - double du1 = Distances[1]; - double du2 = Distances[2]; + bool AllSameSide(array_1d const& Distances) + { + constexpr double epsilon = std::numeric_limits::epsilon(); + + // put U0,U1,U2 into plane equation 1 to compute signed distances to the plane// + double du0 = Distances[0]; + double du1 = Distances[1]; + double du2 = Distances[2]; - // coplanarity robustness check // - if (fabs(du0)0.00 && du0du2>0.00)// same sign on all of them + not equal 0 ? // - return true; // no intersection occurs // + if (du0du1>0.00 && du0du2>0.00)// same sign on all of them + not equal 0 ? // + return true; // no intersection occurs // - return false; + return false; } - int GetMajorAxis(array_1d const& V) { - int index = static_cast(fabs(V[0]) < fabs(V[1])); - return (fabs(V[index]) > fabs(V[2])) ? index : 2; + int GetMajorAxis(array_1d const& V) + { + int index = static_cast(std::abs(V[0]) < std::abs(V[1])); + return (std::abs(V[index]) > std::abs(V[2])) ? index : 2; } - bool HasIntersection(const GeometryType& ThisGeometry) override { - // Based on code develop by Moller: http://fileadmin.cs.lth.se/cs/Personal/Tomas_Akenine-Moller/code/opttritri.txt - // and the article "A Fast Triangle-Triangle Intersection Test", Journal of Graphics Tools, 2(2), 1997: - // http://web.stanford.edu/class/cs277/resources/papers/Moller1997b.pdf - - Plane3D plane_1(this->GetPoint(0), this->GetPoint(1), this->GetPoint(2)); - array_1d distances_1; - for (int i = 0; i < 3; i++) - distances_1[i] = plane_1.CalculateSignedDistance(ThisGeometry[i]); - if (AllSameSide(distances_1)) - return false; - - Plane3D plane_2(ThisGeometry[0], ThisGeometry[1], ThisGeometry[2]); - array_1d distances_2; - for (int i = 0; i < 3; i++) - distances_2[i] = plane_2.CalculateSignedDistance(this->GetPoint(i)); - if (AllSameSide(distances_2)) - return false; - - // compute direction of intersection line // - array_1d intersection_direction; - MathUtils::CrossProduct(intersection_direction, plane_1.GetNormal(), plane_2.GetNormal()); - - int index = GetMajorAxis(intersection_direction); - - // this is the simplified projection onto L// - double vp0 = this->GetPoint(0)[index]; - double vp1 = this->GetPoint(1)[index]; - double vp2 = this->GetPoint(2)[index]; - - double up0 = ThisGeometry[0][index]; - double up1 = ThisGeometry[1][index]; - double up2 = ThisGeometry[2][index]; - - - // compute interval for triangle 1 // - double a, b, c, x0, x1; - if (ComputeIntervals(vp0, vp1, vp2, distances_2[0], distances_2[1], distances_2[2], a, b, c, x0, x1) == true) - { - return CoplanarIntersectionCheck(plane_1.GetNormal(), ThisGeometry); - } + bool HasIntersection(const GeometryType& ThisGeometry) override + { + // Based on code develop by Moller: http://fileadmin.cs.lth.se/cs/Personal/Tomas_Akenine-Moller/code/opttritri.txt + // and the article "A Fast Triangle-Triangle Intersection Test", Journal of Graphics Tools, 2(2), 1997: + // http://web.stanford.edu/class/cs277/resources/papers/Moller1997b.pdf + + Plane3D plane_1(this->GetPoint(0), this->GetPoint(1), this->GetPoint(2)); + array_1d distances_1; + for (int i = 0; i < 3; i++) + distances_1[i] = plane_1.CalculateSignedDistance(ThisGeometry[i]); + if (AllSameSide(distances_1)) + return false; + + Plane3D plane_2(ThisGeometry[0], ThisGeometry[1], ThisGeometry[2]); + array_1d distances_2; + for (int i = 0; i < 3; i++) + distances_2[i] = plane_2.CalculateSignedDistance(this->GetPoint(i)); + if (AllSameSide(distances_2)) + return false; + + // compute direction of intersection line // + array_1d intersection_direction; + MathUtils::CrossProduct(intersection_direction, plane_1.GetNormal(), plane_2.GetNormal()); + + int index = GetMajorAxis(intersection_direction); + + // this is the simplified projection onto L// + double vp0 = this->GetPoint(0)[index]; + double vp1 = this->GetPoint(1)[index]; + double vp2 = this->GetPoint(2)[index]; + + double up0 = ThisGeometry[0][index]; + double up1 = ThisGeometry[1][index]; + double up2 = ThisGeometry[2][index]; + + + // compute interval for triangle 1 // + double a, b, c, x0, x1; + if (ComputeIntervals(vp0, vp1, vp2, distances_2[0], distances_2[1], distances_2[2], a, b, c, x0, x1) == true) + { + return CoplanarIntersectionCheck(plane_1.GetNormal(), ThisGeometry); + } - // compute interval for triangle 2 // - double d, e, f, y0, y1; - if (ComputeIntervals(up0, up1, up2, distances_1[0], distances_1[1], distances_1[2], d, e, f, y0, y1) == true) - { - return CoplanarIntersectionCheck(plane_1.GetNormal(), ThisGeometry); - } + // compute interval for triangle 2 // + double d, e, f, y0, y1; + if (ComputeIntervals(up0, up1, up2, distances_1[0], distances_1[1], distances_1[2], d, e, f, y0, y1) == true) + { + return CoplanarIntersectionCheck(plane_1.GetNormal(), ThisGeometry); + } - double xx, yy, xxyy, tmp; - xx = x0*x1; - yy = y0*y1; - xxyy = xx*yy; + double xx, yy, xxyy, tmp; + xx = x0*x1; + yy = y0*y1; + xxyy = xx*yy; - array_1d isect1, isect2; + array_1d isect1, isect2; - tmp = a*xxyy; - isect1[0] = tmp + b*x1*yy; - isect1[1] = tmp + c*x0*yy; + tmp = a*xxyy; + isect1[0] = tmp + b*x1*yy; + isect1[1] = tmp + c*x0*yy; - tmp = d*xxyy; - isect2[0] = tmp + e*xx*y1; - isect2[1] = tmp + f*xx*y0; + tmp = d*xxyy; + isect2[0] = tmp + e*xx*y1; + isect2[1] = tmp + f*xx*y0; - std::sort(isect1.begin(), isect1.end()); - std::sort(isect2.begin(), isect2.end()); + std::sort(isect1.begin(), isect1.end()); + std::sort(isect2.begin(), isect2.end()); - if (isect1[1] class Triangle3D3 * * @return The inradius to circumradius quality metric. */ - double InradiusToCircumradiusQuality() const override { - constexpr double normFactor = 1.0; + double InradiusToCircumradiusQuality() const override + { + constexpr double normFactor = 1.0; - double a = MathUtils::Norm3(this->GetPoint(0)-this->GetPoint(1)); - double b = MathUtils::Norm3(this->GetPoint(1)-this->GetPoint(2)); - double c = MathUtils::Norm3(this->GetPoint(2)-this->GetPoint(0)); + const double a = MathUtils::Norm3(this->GetPoint(0)-this->GetPoint(1)); + const double b = MathUtils::Norm3(this->GetPoint(1)-this->GetPoint(2)); + const double c = MathUtils::Norm3(this->GetPoint(2)-this->GetPoint(0)); - return normFactor * CalculateInradius(a,b,c) / CalculateCircumradius(a,b,c); + return normFactor * CalculateInradius(a,b,c) / CalculateCircumradius(a,b,c); }; /** Calculates the inradius to longest edge quality metric. @@ -649,18 +662,19 @@ template class Triangle3D3 * * @return The inradius to longest edge quality metric. */ - double InradiusToLongestEdgeQuality() const override { - constexpr double normFactor = 1.0; // TODO: This normalization coeficient is not correct. + double InradiusToLongestEdgeQuality() const override + { + constexpr double normFactor = 1.0; // TODO: This normalization coeficient is not correct. - auto a = this->GetPoint(0) - this->GetPoint(1); - auto b = this->GetPoint(1) - this->GetPoint(2); - auto c = this->GetPoint(2) - this->GetPoint(0); + const array_1d a = this->GetPoint(0) - this->GetPoint(1); + const array_1d b = this->GetPoint(1) - this->GetPoint(2); + const array_1d c = this->GetPoint(2) - this->GetPoint(0); - double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); - double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); - double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); + const double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); + const double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); + const double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); - return normFactor * CalculateInradius(std::sqrt(sa),std::sqrt(sb),std::sqrt(sc)) / CalculateMaxEdgeLength(sa,sb,sc); + return normFactor * CalculateInradius(std::sqrt(sa),std::sqrt(sb),std::sqrt(sc)) / CalculateMaxEdgeLength(sa,sb,sc); } /** Calculates the area to edge length quality metric. @@ -674,18 +688,19 @@ template class Triangle3D3 * * @return The Inradius to Circumradius Quality metric. */ - double AreaToEdgeLengthRatio() const override { - constexpr double normFactor = 1.0; + double AreaToEdgeLengthRatio() const override + { + constexpr double normFactor = 1.0; - auto a = this->GetPoint(0) - this->GetPoint(1); - auto b = this->GetPoint(1) - this->GetPoint(2); - auto c = this->GetPoint(2) - this->GetPoint(0); + const array_1d a = this->GetPoint(0) - this->GetPoint(1); + const array_1d b = this->GetPoint(1) - this->GetPoint(2); + const array_1d c = this->GetPoint(2) - this->GetPoint(0); - double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); - double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); - double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); + const double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); + const double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); + const double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); - return normFactor * Area() / (sa+sb+sc); + return normFactor * Area() / (sa+sb+sc); } /** Calculates the shortest altitude to edge length quality metric. @@ -702,13 +717,13 @@ template class Triangle3D3 double ShortestAltitudeToEdgeLengthRatio() const override { constexpr double normFactor = 1.0; - auto a = this->GetPoint(0) - this->GetPoint(1); - auto b = this->GetPoint(1) - this->GetPoint(2); - auto c = this->GetPoint(2) - this->GetPoint(0); + const array_1d a = this->GetPoint(0) - this->GetPoint(1); + const array_1d b = this->GetPoint(1) - this->GetPoint(2); + const array_1d c = this->GetPoint(2) - this->GetPoint(0); - double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); - double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); - double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); + const double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); + const double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); + const double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); // Shortest altitude is the one intersecting the largest base. double base = CalculateMaxEdgeLength(sa,sb,sc); @@ -730,9 +745,9 @@ template class Triangle3D3 virtual double AreaToEdgeLengthSquareRatio() const { constexpr double normFactor = 1.0; - double a = MathUtils::Norm3(this->GetPoint(0)-this->GetPoint(1)); - double b = MathUtils::Norm3(this->GetPoint(1)-this->GetPoint(2)); - double c = MathUtils::Norm3(this->GetPoint(2)-this->GetPoint(0)); + const double a = MathUtils::Norm3(this->GetPoint(0)-this->GetPoint(1)); + const double b = MathUtils::Norm3(this->GetPoint(1)-this->GetPoint(2)); + const double c = MathUtils::Norm3(this->GetPoint(2)-this->GetPoint(0)); return normFactor * Area() / std::pow(a+b+c, 2); } @@ -748,41 +763,78 @@ template class Triangle3D3 * * @return The shortest altitude to edge length quality metric. */ - virtual double ShortestAltitudeToLongestEdge() const { - constexpr double normFactor = 1.0; + virtual double ShortestAltitudeToLongestEdge() const + { + constexpr double normFactor = 1.0; - auto a = this->GetPoint(0) - this->GetPoint(1); - auto b = this->GetPoint(1) - this->GetPoint(2); - auto c = this->GetPoint(2) - this->GetPoint(0); + const array_1d a = this->GetPoint(0) - this->GetPoint(1); + const array_1d b = this->GetPoint(1) - this->GetPoint(2); + const array_1d c = this->GetPoint(2) - this->GetPoint(0); - double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); - double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); - double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); + const double sa = (a[0]*a[0])+(a[1]*a[1])+(a[2]*a[2]); + const double sb = (b[0]*b[0])+(b[1]*b[1])+(b[2]*b[2]); + const double sc = (c[0]*c[0])+(c[1]*c[1])+(c[2]*c[2]); - // Shortest altitude is the one intersecting the largest base (or edge). - double base = CalculateMaxEdgeLength(sa,sb,sc); + // Shortest altitude is the one intersecting the largest base (or edge). + const double base = CalculateMaxEdgeLength(sa,sb,sc); - return normFactor * (Area() * 2 / base ) / base; + return normFactor * (Area() * 2 / base ) / base; } /** - * Returns whether given arbitrary point is inside the Geometry + * It computes the unit normal of the geometry, if possible + * @return The normal of the geometry */ - - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + array_1d Normal(const CoordinatesArrayType& rPointLocalCoordinates) override + { + const array_1d tangent_xi = this->GetPoint(1) - this->GetPoint(0); + const array_1d tangent_eta = this->GetPoint(2) - this->GetPoint(0); + + array_1d normal; + MathUtils::CrossProduct(normal, tangent_xi, tangent_eta); + return normal/norm_2(normal); + } + + /** + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { PointLocalCoordinates( rResult, rPoint ); if ( (rResult[0] >= (0.0-Tolerance)) && (rResult[0] <= (1.0+Tolerance)) ) + { if ( (rResult[1] >= (0.0-Tolerance)) && (rResult[1] <= (1.0+Tolerance)) ) + { if ( (rResult[0] + rResult[1]) <= (1.0+Tolerance) ) + { return true; + } + } + } return false; } - - CoordinatesArrayType& PointLocalCoordinates( CoordinatesArrayType& rResult, - const CoordinatesArrayType& rPoint ) override + + /** + * Returns the local coordinates of a given arbitrary point + * @param rResult: The vector containing the local coordinates of the point + * @param rPoint: The point in global coordinates + * @return The vector containing the local coordinates of the point + */ + CoordinatesArrayType& PointLocalCoordinates( + CoordinatesArrayType& rResult, + const CoordinatesArrayType& rPoint + ) override { boost::numeric::ublas::bounded_matrix X; boost::numeric::ublas::bounded_matrix DN; @@ -1944,9 +1996,9 @@ template class Triangle3D3 // first project onto an axis-aligned plane, that maximizes the area // // of the triangles, compute indices: i0,i1. // - A[0] = fabs(N[0]); - A[1] = fabs(N[1]); - A[2] = fabs(N[2]); + A[0] = std::abs(N[0]); + A[1] = std::abs(N[1]); + A[2] = std::abs(N[2]); if (A[0]>A[1]) { if (A[0]>A[2]) @@ -2040,8 +2092,8 @@ template class Triangle3D3 f = Ay*Bx - Ax*By; d = By*Cx - Bx*Cy; - if (std::fabs(f)<1E-10) f = 0.00; - if (std::fabs(d)<1E-10) d = 0.00; + if (std::abs(f)<1E-10) f = 0.00; + if (std::abs(d)<1E-10) d = 0.00; if ((f>0.00 && d >= 0.00 && d <= f) || (f<0.00 && d <= 0.00 && d >= f)) diff --git a/kratos/geometries/triangle_3d_6.h b/kratos/geometries/triangle_3d_6.h index 079773880aed..f0f144eff45b 100644 --- a/kratos/geometries/triangle_3d_6.h +++ b/kratos/geometries/triangle_3d_6.h @@ -466,18 +466,33 @@ template class Triangle3D6 { return Area(); } - + /** - * Returns whether given arbitrary point is inside the Geometry - */ - bool IsInside( const CoordinatesArrayType& rPoint, CoordinatesArrayType& rResult, const double Tolerance = std::numeric_limits::epsilon() ) override + * Returns whether given arbitrary point is inside the Geometry and the respective + * local point for the given global point + * @param rPoint: The point to be checked if is inside o note in global coordinates + * @param rResult: The local coordinates of the point + * @param Tolerance: The tolerance that will be considered to check if the point is inside or not + * @return True if the point is inside, false otherwise + */ + virtual bool IsInside( + const CoordinatesArrayType& rPoint, + CoordinatesArrayType& rResult, + const double Tolerance = std::numeric_limits::epsilon() + ) override { this->PointLocalCoordinates( rResult, rPoint ); if ( (rResult[0] >= (0.0-Tolerance)) && (rResult[0] <= (1.0+Tolerance)) ) + { if ( (rResult[1] >= (0.0-Tolerance)) && (rResult[1] <= (1.0+Tolerance)) ) + { if ( (rResult[0] + rResult[1]) <= (1.0+Tolerance) ) + { return true; + } + } + } return false; } diff --git a/kratos/includes/constitutive_law.h b/kratos/includes/constitutive_law.h index 001cdf4b1ebc..a265124ec45a 100644 --- a/kratos/includes/constitutive_law.h +++ b/kratos/includes/constitutive_law.h @@ -87,17 +87,24 @@ class KRATOS_API(KRATOS_CORE) ConstitutiveLaw : public Flags /** * Flags related to the Parameters of the Contitutive Law - */ - KRATOS_DEFINE_LOCAL_FLAG( COMPUTE_STRAIN ); + */ + KRATOS_DEFINE_LOCAL_FLAG( USE_ELEMENT_PROVIDED_STRAIN ); KRATOS_DEFINE_LOCAL_FLAG( COMPUTE_STRESS ); KRATOS_DEFINE_LOCAL_FLAG( COMPUTE_CONSTITUTIVE_TENSOR ); KRATOS_DEFINE_LOCAL_FLAG( COMPUTE_STRAIN_ENERGY ); - + KRATOS_DEFINE_LOCAL_FLAG( ISOCHORIC_TENSOR_ONLY ); KRATOS_DEFINE_LOCAL_FLAG( VOLUMETRIC_TENSOR_ONLY ); + + KRATOS_DEFINE_LOCAL_FLAG( MECHANICAL_RESPONSE_ONLY ); + KRATOS_DEFINE_LOCAL_FLAG( THERMAL_RESPONSE_ONLY ); - KRATOS_DEFINE_LOCAL_FLAG( TOTAL_TENSOR ); + KRATOS_DEFINE_LOCAL_FLAG( INCREMENTAL_STRAIN_MEASURE ); + + ///the next two flags are designed for internal use within the constitutive law. + ///please DO NOT use them from the API + KRATOS_DEFINE_LOCAL_FLAG( INITIALIZE_MATERIAL_RESPONSE ); KRATOS_DEFINE_LOCAL_FLAG( FINALIZE_MATERIAL_RESPONSE ); @@ -186,7 +193,7 @@ class KRATOS_API(KRATOS_CORE) ConstitutiveLaw : public Flags * @param mDeterminantF copy of the determinant of the Current DeformationGradient (although Current F is also included as a matrix) (input data) * @param mpDeformationGradientF pointer to the current deformation gradient (can be an empty matrix if a linear strain measure is used) (input data) - * @param mpStrainVector pointer to the current strains (total strains) (input data) (*can be also OUTPUT with COMPUTE_STRAIN flag) + * @param mpStrainVector pointer to the current strains (total strains) (input data) (*can be also OUTPUT with USE_ELEMENT_PROVIDED_STRAIN flag) * @param mpStressVector pointer to the current stresses (*OUTPUT with COMPUTE_STRESS flag) * @param mpConstitutiveMatrix pointer to the material tangent matrix (*OUTPUT with COMPUTE_CONSTITUTIVE_TENSOR flag) @@ -627,15 +634,60 @@ class KRATOS_API(KRATOS_CORE) ConstitutiveLaw : public Flags const ProcessInfo& rCurrentProcessInfo); /** - * Is called to check whether the provided material parameters in the Properties - * match the requirements of current constitutive model. - * @param rMaterialProperties the current Properties to be validated against. - * @return true, if parameters are correct; false, if parameters are insufficient / faulty - * NOTE: this has to be implemented by each constitutive model. Returns false in base class since - * no valid implementation is contained here. + * calculates the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ + virtual int& CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, int& rValue); + + /** + * calculates the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ + virtual double& CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, double& rValue); + + /** + * calculates the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ + virtual Vector& CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, Vector& rValue); + + /** + * calculates the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ + virtual Matrix& CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, Matrix& rValue); + + /** + * calculates the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable */ - virtual bool ValidateInput(const Properties& rMaterialProperties); + virtual array_1d & CalculateValue(Parameters& rParameterValues, const Variable >& rVariable, + array_1d & rValue); + /** + * returns the value of a specified variable + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @return the value of the specified variable + */ + virtual array_1d & CalculateValue(Parameters& rParameterValues, const Variable >& rVariable, + array_1d & rValue); + /** * returns the expected strain measure of this constitutive law (by default linear strains) * @return the expected strain measure @@ -762,8 +814,47 @@ class KRATOS_API(KRATOS_CORE) ConstitutiveLaw : public Flags virtual void CalculateMaterialResponseCauchy (Parameters& rValues); + + /** + * Initialize the material response, called by the element in FinalizeSolutionStep. + * @see Parameters + * @see StressMeasures + */ + void InitializeMaterialResponse (Parameters& rValues,const StressMeasure& rStressMeasure); + + + /** + * Initialize the material response in terms of 1st Piola-Kirchhoff stresses + * @see Parameters + */ + + virtual void InitializeMaterialResponsePK1 (Parameters& rValues); + + /** + * Initialize the material response in terms of 2nd Piola-Kirchhoff stresses + * @see Parameters + */ + + virtual void InitializeMaterialResponsePK2 (Parameters& rValues); + + /** + * Initialize the material response in terms of Kirchhoff stresses + * @see Parameters + */ + + virtual void InitializeMaterialResponseKirchhoff (Parameters& rValues); + + /** + * Initialize the material response in terms of Cauchy stresses + * @see Parameters + */ + + virtual void InitializeMaterialResponseCauchy (Parameters& rValues); + + + /** - * Updates the material response, called by the element in FinalizeSolutionStep. + * Finalize the material response, called by the element in FinalizeSolutionStep. * @see Parameters * @see StressMeasures */ @@ -771,28 +862,28 @@ class KRATOS_API(KRATOS_CORE) ConstitutiveLaw : public Flags /** - * Updates the material response in terms of 1st Piola-Kirchhoff stresses + * Finalize the material response in terms of 1st Piola-Kirchhoff stresses * @see Parameters */ virtual void FinalizeMaterialResponsePK1 (Parameters& rValues); /** - * Updates the material response in terms of 2nd Piola-Kirchhoff stresses + * Finalize the material response in terms of 2nd Piola-Kirchhoff stresses * @see Parameters */ virtual void FinalizeMaterialResponsePK2 (Parameters& rValues); /** - * Updates the material response in terms of Kirchhoff stresses + * Finalize the material response in terms of Kirchhoff stresses * @see Parameters */ virtual void FinalizeMaterialResponseKirchhoff (Parameters& rValues); /** - * Updates the material response in terms of Cauchy stresses + * Finalize the material response in terms of Cauchy stresses * @see Parameters */ diff --git a/kratos/includes/gid_gauss_point_container.h b/kratos/includes/gid_gauss_point_container.h index 0abfc77cc340..aff2e9e8cbf5 100644 --- a/kratos/includes/gid_gauss_point_container.h +++ b/kratos/includes/gid_gauss_point_container.h @@ -436,6 +436,20 @@ class GidGaussPointsContainer GiD_fWriteGaussPoint2D( MeshFile, - 1.00/std::sqrt(3.0), 1.00/std::sqrt(3.0) ); GiD_fEndGaussPoint(MeshFile); } + else if( mGidElementFamily == GiD_Quadrilateral && mSize == 9 ) + { + GiD_fBeginGaussPoint( MeshFile, mGPTitle, GiD_Quadrilateral, NULL, 9, 0, 0 ); + GiD_fWriteGaussPoint2D( MeshFile, -std::sqrt(3.00/5.00) , -std::sqrt(3.00/5.00)); + GiD_fWriteGaussPoint2D( MeshFile, 0.00 , -std::sqrt(3.00/5.00) ); + GiD_fWriteGaussPoint2D( MeshFile, std::sqrt(3.00/5.00) , -std::sqrt(3.00/5.00) ); + GiD_fWriteGaussPoint2D( MeshFile, -std::sqrt(3.00/5.00), 0.00 ); + GiD_fWriteGaussPoint2D( MeshFile, 0.00 , 0.00 ); + GiD_fWriteGaussPoint2D( MeshFile, std::sqrt(3.00/5.00), 0.00); + GiD_fWriteGaussPoint2D( MeshFile, -std::sqrt(3.00/5.00), std::sqrt(3.00/5.00) ); + GiD_fWriteGaussPoint2D( MeshFile, 0.00, std::sqrt(3.00/5.00) ); + GiD_fWriteGaussPoint2D( MeshFile, std::sqrt(3.00/5.00), std::sqrt(3.00/5.00) ); + GiD_fEndGaussPoint(MeshFile); + } else if( mGidElementFamily == GiD_Tetrahedra && mSize == 5 ) { GiD_fBeginGaussPoint( MeshFile, mGPTitle, GiD_Tetrahedra, NULL, 4, 0, 0 ); diff --git a/kratos/includes/model_part.h b/kratos/includes/model_part.h index aa0072462b47..b47c3b0f3580 100644 --- a/kratos/includes/model_part.h +++ b/kratos/includes/model_part.h @@ -251,7 +251,7 @@ class KRATOS_API(KRATOS_CORE) ModelPart : public DataValueContainer, public Flag ModelPart(std::string const& NewName, IndexType NewBufferSize); /// Copy constructor. - ModelPart(ModelPart const& rOther); + explicit ModelPart(ModelPart const& rOther); /// Destructor. diff --git a/kratos/includes/variables.h b/kratos/includes/variables.h index 32df6c6b560e..b755b7e90358 100644 --- a/kratos/includes/variables.h +++ b/kratos/includes/variables.h @@ -38,8 +38,6 @@ namespace Kratos { - typedef array_1d Vector3; - //Define Variables by type: //bools @@ -154,7 +152,7 @@ namespace Kratos KRATOS_DEFINE_VARIABLE( double, REACTION_AIR_PRESSURE ) KRATOS_DEFINE_VARIABLE( double, FLAG_VARIABLE ) KRATOS_DEFINE_VARIABLE( double, DISTANCE ) - KRATOS_DEFINE_VARIABLE( Vector3, DISTANCE_GRADIENT ) + KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS( DISTANCE_GRADIENT ) KRATOS_DEFINE_VARIABLE( double, LAGRANGE_AIR_PRESSURE ) KRATOS_DEFINE_VARIABLE( double, LAGRANGE_WATER_PRESSURE ) @@ -185,6 +183,10 @@ namespace Kratos KRATOS_DEFINE_VARIABLE( Matrix, SHAPE_DERIVATIVE_MATRIX_1 ) KRATOS_DEFINE_VARIABLE( Matrix, SHAPE_DERIVATIVE_MATRIX_2 ) + // For MeshingApplication + KRATOS_DEFINE_VARIABLE( double, NODAL_ERROR ) + KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS( NODAL_ERROR_COMPONENTS ) + //for PFEM fluids application: KRATOS_DEFINE_VARIABLE( double, NODAL_AREA ) @@ -432,6 +434,7 @@ namespace Kratos KRATOS_DEFINE_VARIABLE(double, SEARCH_RADIUS ) KRATOS_DEFINE_VARIABLE(double, INTEGRATION_WEIGHT ) + KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS( INTEGRATION_COORDINATES ) // for Vulcan application // KRATOS_DEFINE_VARIABLE(double, LAST_AIR) diff --git a/kratos/modeler/connectivity_preserve_modeler.h b/kratos/modeler/connectivity_preserve_modeler.h new file mode 100644 index 000000000000..b57008aabcba --- /dev/null +++ b/kratos/modeler/connectivity_preserve_modeler.h @@ -0,0 +1,109 @@ +// | / | +// ' / __| _` | __| _ \ __| +// . \ | ( | | ( |\__ ` +// _|\_\_| \__,_|\__|\___/ ____/ +// Multi-Physics +// +// License: BSD License +// Kratos default license: kratos/license.txt +// +// Main authors: Riccardo Rossi +// +// + +#if !defined( KRATOS_CONNECTIVITY_PRESERVE_MODELER_H ) +#define KRATOS_CONNECTIVITY_PRESERVE_MODELER_H + + + +// System includes +#include +#include +#include + +// External includes + + +// Project includes +#include "includes/define.h" +#include "includes/model_part.h" +#include "includes/node.h" +#include "modeler/modeler.h" + + +namespace Kratos +{ + +/// A tool to generate a copy of a ModelPart, sharing the same nodes as the original. +class ConnectivityPreserveModeler : public Modeler +{ +public: + + KRATOS_CLASS_POINTER_DEFINITION(ConnectivityPreserveModeler); + + /// Constructor + ConnectivityPreserveModeler(); + + /// Destructor. + virtual ~ConnectivityPreserveModeler() override; + + /// Generate a copy of rOriginModelPart in rDestinationModelPart, using the given element and condtion types. + /** This function fills rDestinationModelPart using data obtained from rOriginModelPart. The elements + * and conditions of rDestinationModelPart part use the same connectivity (and id) as in + * rOriginModelPart but their type is determined by rReferenceElement and rReferenceBoundaryCondition. + * Note that both ModelParts will share the same nodes, as well as ProcessInfo and tables. + * SubModelParts and, in MPI, communicator data will be replicated in DestinationModelPart. + * @param rOriginModelPart The source ModelPart. + * @param rDestinationModelPart The ModelPart to be filled by this function. + * @param rReferenceElement The Element type for rDestinationModelPart. + * @param rReferenceBoundaryCondition The Condition type for rDestinationModelPart. + */ + virtual void GenerateModelPart( + ModelPart& OriginModelPart, + ModelPart& DestinationModelPart, + Element const& rReferenceElement, + Condition const& rReferenceBoundaryCondition + ) override; + +private: + + void ResetModelPart(ModelPart &rDestinationModelPart); + + void CopyCommonData( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart + ); + + void DuplicateElements( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart, + Element const &rReferenceElement + ); + + void DuplicateConditions( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart, + Condition const &rReferenceBoundaryCondition + ); + + void DuplicateCommunicatorData( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart + ); + + void DuplicateSubModelParts( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart + ); + + ConnectivityPreserveModeler & operator=(ConnectivityPreserveModeler const& rOther); + + /// Copy constructor. + ConnectivityPreserveModeler(ConnectivityPreserveModeler const& rOther); + + +}; + +} // namespace Kratos. + +#endif //KRATOS_GENERATE_MODEL_PART_MODELER_INCLUDED defined diff --git a/kratos/modeler/mpi_connectivity_preserve_modeler.h b/kratos/modeler/mpi_connectivity_preserve_modeler.h deleted file mode 100644 index bcacc9f073be..000000000000 --- a/kratos/modeler/mpi_connectivity_preserve_modeler.h +++ /dev/null @@ -1,85 +0,0 @@ -/* -============================================================================== -KratosMeshingApplication -A library based on: -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -- CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNERS. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== - */ - - -#ifndef KRATOS_MPI_CONNECTIVITY_PRESERVE_MODELER_H -#define KRATOS_MPI_CONNECTIVITY_PRESERVE_MODELER_H - -// system includes - -// kratos includes -#include "includes/element.h" -#include "includes/condition.h" -#include "includes/model_part.h" -#include "modeler/modeler.h" - -namespace Kratos -{ - -class MPIConnectivityPreserveModeler : public Modeler -{ -public: - - KRATOS_CLASS_POINTER_DEFINITION(MPIConnectivityPreserveModeler); - - - /// Default Constructor - MPIConnectivityPreserveModeler(); - - - /// Destructor - ~MPIConnectivityPreserveModeler(); - - virtual void GenerateModelPart(ModelPart &OriginModelPart, - ModelPart &DestinationModelPart, - const Element &rReferenceElement, - const Condition &rReferenceBoundaryCondition) override; - -private: - - /// Copy constructor - MPIConnectivityPreserveModeler(const MPIConnectivityPreserveModeler &rOther); - -}; - -} - -#endif // KRATOS_MPI_CONNECTIVITY_PRESERVE_MODELER_H diff --git a/kratos/processes/compute_nodal_gradient_process.h b/kratos/processes/compute_nodal_gradient_process.h index ccfd7e57e30f..a536925e9825 100644 --- a/kratos/processes/compute_nodal_gradient_process.h +++ b/kratos/processes/compute_nodal_gradient_process.h @@ -46,6 +46,11 @@ namespace Kratos ///@name Enum's ///@{ + #if !defined(HISTORICAL_VALUES) + #define HISTORICAL_VALUES + enum HistoricalValues {Historical = 0, NonHistorical = 1}; + #endif + ///@} ///@name Functions ///@{ @@ -54,12 +59,11 @@ namespace Kratos ///@name Kratos Classes ///@{ -/// Short class definition. -//erases the nodes marked as -/** Detail class definition. +/// Compute Nodal Gradient process +/** This process computes the gradient of a certain variable stored in the nodes */ -template< int TDim, class TVarType > +template< int TDim, class TVarType, HistoricalValues THist> class ComputeNodalGradientProcess : public Process { @@ -75,10 +79,10 @@ class ComputeNodalGradientProcess ///@{ /// Default constructor. - ComputeNodalGradientProcess(ModelPart& model_part - , TVarType& r_origin_variable - , Variable >& r_gradient_variable - , Variable& r_area_variable); + ComputeNodalGradientProcess(ModelPart& rModelPart + , TVarType& rOriginVariable + , Variable >& rGradientVariable + , Variable& rAreaVariable); /// Destructor. ~ComputeNodalGradientProcess() override @@ -104,31 +108,24 @@ class ComputeNodalGradientProcess { KRATOS_TRY; - //set to zero + // Set to zero + ClearGradient(); - #pragma omp parallel for - for(int i=0; i(mr_model_part.Nodes().size()); i++) - { - auto it=mr_model_part.NodesBegin()+i; - it->FastGetSolutionStepValue(mr_area_variable) = 0.0; - it->FastGetSolutionStepValue(mr_gradient_variable).clear(); - } - - boost::numeric::ublas::bounded_matrix DN_DX; + bounded_matrix DN_DX; array_1d N; double Volume; #pragma omp parallel for private(DN_DX, N, Volume) - for(int i=0; i(mr_model_part.Elements().size()); i++) + for(int i=0; i(mrModelPart.Elements().size()); i++) { - auto it=mr_model_part.ElementsBegin()+i; + auto it=mrModelPart.ElementsBegin()+i; Element::GeometryType& geom = it->GetGeometry(); GeometryUtils::CalculateGeometryData(geom, DN_DX, N, Volume); array_1d values; for(unsigned int i=0; i grad = prod(trans(DN_DX), values); @@ -137,25 +134,20 @@ class ComputeNodalGradientProcess { for(unsigned int k=0; k(mr_model_part.Nodes().size()); i++) - { - auto it=mr_model_part.NodesBegin()+i; - it->FastGetSolutionStepValue(mr_gradient_variable) /= it->FastGetSolutionStepValue(mr_area_variable); - } + PonderateGradient(); KRATOS_CATCH("") } @@ -245,11 +237,11 @@ class ComputeNodalGradientProcess ///@} ///@name Member Variables ///@{ - ModelPart& mr_model_part; - TVarType& mr_origin_variable; - Variable >& mr_gradient_variable; - Variable& mr_area_variable; - + + ModelPart& mrModelPart; + TVarType& mrOriginVariable; + Variable >& mrGradientVariable; + Variable& mrAreaVariable; ///@} ///@name Private Operators @@ -259,6 +251,29 @@ class ComputeNodalGradientProcess ///@name Private Operations ///@{ + // TODO: Try to use enable_if!!! + + /** + * This clears the gradient + */ + void ClearGradient(); + + /** + * This gets the gradient value + * @param geom: The geometry of the element + * @param i: The node index + * @param k: The component index + */ + double& GetGradient( + Element::GeometryType& geom, + unsigned int i, + unsigned int k + ); + + /** + * This divides the gradient value by the nodal area + */ + void PonderateGradient(); ///@} ///@name Private Access @@ -315,113 +330,497 @@ class ComputeNodalGradientProcess ///@{ template<> - ComputeNodalGradientProcess<2, Variable>::ComputeNodalGradientProcess(ModelPart& model_part - , Variable& r_origin_variable - , Variable >& r_gradient_variable - , Variable& r_area_variable) - :mr_model_part(model_part), mr_origin_variable(r_origin_variable), mr_gradient_variable(r_gradient_variable), mr_area_variable(r_area_variable) + ComputeNodalGradientProcess<2, Variable, Historical>::ComputeNodalGradientProcess( + ModelPart& rModelPart, + Variable& rOriginVariable, + Variable >& rGradientVariable, + Variable& rAreaVariable) + :mrModelPart(rModelPart), mrOriginVariable(rOriginVariable), mrGradientVariable(rGradientVariable), mrAreaVariable(rAreaVariable) { KRATOS_TRY - if (model_part.GetNodalSolutionStepVariablesList().Has( r_origin_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rOriginVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_origin_variable; + KRATOS_ERROR << "Missing variable " << rOriginVariable; } - if (model_part.GetNodalSolutionStepVariablesList().Has( r_gradient_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rGradientVariable ) == false ) + { + KRATOS_ERROR << "Missing variable " << rGradientVariable; + } + + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rAreaVariable ) == false ) + { + KRATOS_ERROR << "Missing variable " << rAreaVariable; + } + + KRATOS_CATCH("") + } + + template<> + ComputeNodalGradientProcess<2, Variable, NonHistorical>::ComputeNodalGradientProcess( + ModelPart& rModelPart, + Variable& rOriginVariable, + Variable >& rGradientVariable, + Variable& rAreaVariable) + :mrModelPart(rModelPart), mrOriginVariable(rOriginVariable), mrGradientVariable(rGradientVariable), mrAreaVariable(rAreaVariable) + { + KRATOS_TRY + + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rOriginVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_gradient_variable; + KRATOS_ERROR << "Missing variable " << rOriginVariable; } - if (model_part.GetNodalSolutionStepVariablesList().Has( r_area_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rAreaVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_area_variable; + KRATOS_ERROR << "Missing variable " << rAreaVariable; } KRATOS_CATCH("") } template<> - ComputeNodalGradientProcess<3, Variable>::ComputeNodalGradientProcess(ModelPart& model_part - , Variable& r_origin_variable - , Variable >& r_gradient_variable - , Variable& r_area_variable) - :mr_model_part(model_part), mr_origin_variable(r_origin_variable), mr_gradient_variable(r_gradient_variable), mr_area_variable(r_area_variable) + ComputeNodalGradientProcess<3, Variable, Historical>::ComputeNodalGradientProcess( + ModelPart& rModelPart, + Variable& rOriginVariable, + Variable >& rGradientVariable, + Variable& rAreaVariable) + :mrModelPart(rModelPart), mrOriginVariable(rOriginVariable), mrGradientVariable(rGradientVariable), mrAreaVariable(rAreaVariable) { KRATOS_TRY - if (model_part.GetNodalSolutionStepVariablesList().Has( r_origin_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rOriginVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_origin_variable; + KRATOS_ERROR << "Missing variable " << rOriginVariable; } - if (model_part.GetNodalSolutionStepVariablesList().Has( r_gradient_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rGradientVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_gradient_variable; + KRATOS_ERROR << "Missing variable " << rGradientVariable; } - if (model_part.GetNodalSolutionStepVariablesList().Has( r_area_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rAreaVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_area_variable; + KRATOS_ERROR << "Missing variable " << rAreaVariable; } KRATOS_CATCH("") } template<> - ComputeNodalGradientProcess<2, component_type>::ComputeNodalGradientProcess(ModelPart& model_part - , component_type& r_origin_variable - , Variable >& r_gradient_variable - , Variable& r_area_variable) - :mr_model_part(model_part), mr_origin_variable(r_origin_variable), mr_gradient_variable(r_gradient_variable), mr_area_variable(r_area_variable) + ComputeNodalGradientProcess<3, Variable, NonHistorical>::ComputeNodalGradientProcess( + ModelPart& rModelPart, + Variable& rOriginVariable, + Variable >& rGradientVariable, + Variable& rAreaVariable) + :mrModelPart(rModelPart), mrOriginVariable(rOriginVariable), mrGradientVariable(rGradientVariable), mrAreaVariable(rAreaVariable) { KRATOS_TRY - if (model_part.GetNodalSolutionStepVariablesList().Has( r_origin_variable.GetSourceVariable() ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rOriginVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_origin_variable.GetSourceVariable(); + KRATOS_ERROR << "Missing variable " << rOriginVariable; } - if (model_part.GetNodalSolutionStepVariablesList().Has( r_gradient_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rAreaVariable ) == false ) + { + KRATOS_ERROR << "Missing variable " << rAreaVariable; + } + + KRATOS_CATCH("") + } + + template<> + ComputeNodalGradientProcess<2, component_type, Historical>::ComputeNodalGradientProcess( + ModelPart& rModelPart, + component_type& rOriginVariable, + Variable >& rGradientVariable, + Variable& rAreaVariable) + :mrModelPart(rModelPart), mrOriginVariable(rOriginVariable), mrGradientVariable(rGradientVariable), mrAreaVariable(rAreaVariable) + { + KRATOS_TRY + + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rOriginVariable.GetSourceVariable() ) == false ) + { + KRATOS_ERROR << "Missing variable " << rOriginVariable.GetSourceVariable(); + } + + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rGradientVariable ) == false ) + { + KRATOS_ERROR << "Missing variable " << rGradientVariable; + } + + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rAreaVariable ) == false ) + { + KRATOS_ERROR << "Missing variable " << rAreaVariable; + } + + KRATOS_CATCH("") + } + + template<> + ComputeNodalGradientProcess<2, component_type, NonHistorical>::ComputeNodalGradientProcess( + ModelPart& rModelPart, + component_type& rOriginVariable, + Variable >& rGradientVariable, + Variable& rAreaVariable) + :mrModelPart(rModelPart), mrOriginVariable(rOriginVariable), mrGradientVariable(rGradientVariable), mrAreaVariable(rAreaVariable) + { + KRATOS_TRY + + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rOriginVariable.GetSourceVariable() ) == false ) { - KRATOS_ERROR << "missing variable " << r_gradient_variable; + KRATOS_ERROR << "Missing variable " << rOriginVariable.GetSourceVariable(); } - if (model_part.GetNodalSolutionStepVariablesList().Has( r_area_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rAreaVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_area_variable; + KRATOS_ERROR << "Missing variable " << rAreaVariable; } KRATOS_CATCH("") } template<> - ComputeNodalGradientProcess<3, component_type>::ComputeNodalGradientProcess(ModelPart& model_part - , component_type& r_origin_variable - , Variable >& r_gradient_variable - , Variable& r_area_variable) - :mr_model_part(model_part), mr_origin_variable(r_origin_variable), mr_gradient_variable(r_gradient_variable), mr_area_variable(r_area_variable) + ComputeNodalGradientProcess<3, component_type, Historical>::ComputeNodalGradientProcess( + ModelPart& rModelPart, + component_type& rOriginVariable, + Variable >& rGradientVariable, + Variable& rAreaVariable) + :mrModelPart(rModelPart), mrOriginVariable(rOriginVariable), mrGradientVariable(rGradientVariable), mrAreaVariable(rAreaVariable) { KRATOS_TRY - if (model_part.GetNodalSolutionStepVariablesList().Has( r_origin_variable.GetSourceVariable() ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rOriginVariable.GetSourceVariable() ) == false ) { - KRATOS_ERROR << "missing variable " << r_origin_variable.GetSourceVariable(); + KRATOS_ERROR << "Missing variable " << rOriginVariable.GetSourceVariable(); } - if (model_part.GetNodalSolutionStepVariablesList().Has( r_gradient_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rGradientVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_gradient_variable; + KRATOS_ERROR << "Missing variable " << rGradientVariable; } - if (model_part.GetNodalSolutionStepVariablesList().Has( r_area_variable ) == false ) + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rAreaVariable ) == false ) { - KRATOS_ERROR << "missing variable " << r_area_variable; + KRATOS_ERROR << "Missing variable " << rAreaVariable; } KRATOS_CATCH("") } + + template<> + ComputeNodalGradientProcess<3, component_type, NonHistorical>::ComputeNodalGradientProcess( + ModelPart& rModelPart, + component_type& rOriginVariable, + Variable >& rGradientVariable, + Variable& rAreaVariable) + :mrModelPart(rModelPart), mrOriginVariable(rOriginVariable), mrGradientVariable(rGradientVariable), mrAreaVariable(rAreaVariable) + { + KRATOS_TRY + + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rOriginVariable.GetSourceVariable() ) == false ) + { + KRATOS_ERROR << "Missing variable " << rOriginVariable.GetSourceVariable(); + } + + if (rModelPart.GetNodalSolutionStepVariablesList().Has( rAreaVariable ) == false ) + { + KRATOS_ERROR << "Missing variable " << rAreaVariable; + } + + KRATOS_CATCH("") + } + + template<> + void ComputeNodalGradientProcess<2, Variable, Historical>::ClearGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrAreaVariable) = 0.0; + it->FastGetSolutionStepValue(mrGradientVariable).clear(); + } + } + + template<> + void ComputeNodalGradientProcess<3, Variable, Historical>::ClearGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrAreaVariable) = 0.0; + it->FastGetSolutionStepValue(mrGradientVariable).clear(); + } + } + + template<> + void ComputeNodalGradientProcess<2, component_type, Historical>::ClearGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrAreaVariable) = 0.0; + it->FastGetSolutionStepValue(mrGradientVariable).clear(); + } + } + + template<> + void ComputeNodalGradientProcess<3, component_type, Historical>::ClearGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrAreaVariable) = 0.0; + it->FastGetSolutionStepValue(mrGradientVariable).clear(); + } + } + + template <> + void ComputeNodalGradientProcess<2, Variable, NonHistorical>::ClearGradient() + { + const array_1d AuxZeroVector = ZeroVector(3); + + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrAreaVariable) = 0.0; + it->SetValue(mrGradientVariable, AuxZeroVector); + } + } + + template <> + void ComputeNodalGradientProcess<3, Variable, NonHistorical>::ClearGradient() + { + const array_1d AuxZeroVector = ZeroVector(3); + + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrAreaVariable) = 0.0; + it->SetValue(mrGradientVariable, AuxZeroVector); + } + } + + template <> + void ComputeNodalGradientProcess<2, component_type, NonHistorical>::ClearGradient() + { + const array_1d AuxZeroVector = ZeroVector(3); + + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrAreaVariable) = 0.0; + it->SetValue(mrGradientVariable, AuxZeroVector); + } + } + + template <> + void ComputeNodalGradientProcess<3, component_type, NonHistorical>::ClearGradient() + { + const array_1d AuxZeroVector = ZeroVector(3); + + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrAreaVariable) = 0.0; + it->SetValue(mrGradientVariable, AuxZeroVector); + } + } + + template <> + double& ComputeNodalGradientProcess<2, Variable, Historical>::GetGradient( + Element::GeometryType& geom, + unsigned int i, + unsigned int k + ) + { + double& val = geom[i].FastGetSolutionStepValue(mrGradientVariable)[k]; + + return val; + } + + template <> + double& ComputeNodalGradientProcess<3, Variable, Historical>::GetGradient( + Element::GeometryType& geom, + unsigned int i, + unsigned int k + ) + { + double& val = geom[i].FastGetSolutionStepValue(mrGradientVariable)[k]; + + return val; + } + + template <> + double& ComputeNodalGradientProcess<2, component_type, Historical>::GetGradient( + Element::GeometryType& geom, + unsigned int i, + unsigned int k + ) + { + double& val = geom[i].FastGetSolutionStepValue(mrGradientVariable)[k]; + + return val; + } + + template <> + double& ComputeNodalGradientProcess<3, component_type, Historical>::GetGradient( + Element::GeometryType& geom, + unsigned int i, + unsigned int k + ) + { + double& val = geom[i].FastGetSolutionStepValue(mrGradientVariable)[k]; + + return val; + } + + template <> + double& ComputeNodalGradientProcess<2, Variable, NonHistorical>::GetGradient( + Element::GeometryType& geom, + unsigned int i, + unsigned int k + ) + { + double& val = geom[i].GetValue(mrGradientVariable)[k]; + + return val; + } + + template <> + double& ComputeNodalGradientProcess<3, Variable, NonHistorical>::GetGradient( + Element::GeometryType& geom, + unsigned int i, + unsigned int k + ) + { + double& val = geom[i].GetValue(mrGradientVariable)[k]; + + return val; + } + + template <> + double& ComputeNodalGradientProcess<2, component_type, NonHistorical>::GetGradient( + Element::GeometryType& geom, + unsigned int i, + unsigned int k + ) + { + double& val = geom[i].GetValue(mrGradientVariable)[k]; + + return val; + } + + template <> + double& ComputeNodalGradientProcess<3, component_type, NonHistorical>::GetGradient( + Element::GeometryType& geom, + unsigned int i, + unsigned int k + ) + { + double& val = geom[i].GetValue(mrGradientVariable)[k]; + + return val; + } + + template <> + void ComputeNodalGradientProcess<2, Variable, Historical>::PonderateGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrGradientVariable) /= it->FastGetSolutionStepValue(mrAreaVariable); + } + } + + template <> + void ComputeNodalGradientProcess<3, Variable, Historical>::PonderateGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrGradientVariable) /= it->FastGetSolutionStepValue(mrAreaVariable); + } + } + + template <> + void ComputeNodalGradientProcess<2, component_type, Historical>::PonderateGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrGradientVariable) /= it->FastGetSolutionStepValue(mrAreaVariable); + } + } + + template <> + void ComputeNodalGradientProcess<3, component_type, Historical>::PonderateGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->FastGetSolutionStepValue(mrGradientVariable) /= it->FastGetSolutionStepValue(mrAreaVariable); + } + } + + template <> + void ComputeNodalGradientProcess<2, Variable, NonHistorical>::PonderateGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->GetValue(mrGradientVariable) /= it->FastGetSolutionStepValue(mrAreaVariable); + } + } + template <> + void ComputeNodalGradientProcess<3, Variable, NonHistorical>::PonderateGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->GetValue(mrGradientVariable) /= it->FastGetSolutionStepValue(mrAreaVariable); + } + } + + template <> + void ComputeNodalGradientProcess<2, component_type, NonHistorical>::PonderateGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->GetValue(mrGradientVariable) /= it->FastGetSolutionStepValue(mrAreaVariable); + } + } + + template <> + void ComputeNodalGradientProcess<3, component_type, NonHistorical>::PonderateGradient() + { + #pragma omp parallel for + for(int i=0; i(mrModelPart.Nodes().size()); i++) + { + auto it=mrModelPart.NodesBegin()+i; + it->GetValue(mrGradientVariable) /= it->FastGetSolutionStepValue(mrAreaVariable); + } + } + } // namespace Kratos. #endif // KRATOS_COMPUTE_GRADIENT_PROCESS_INCLUDED defined diff --git a/kratos/python/add_constitutive_law_to_python.cpp b/kratos/python/add_constitutive_law_to_python.cpp index fdc44f2aa164..4c0859b56594 100644 --- a/kratos/python/add_constitutive_law_to_python.cpp +++ b/kratos/python/add_constitutive_law_to_python.cpp @@ -189,6 +189,11 @@ void AddConstitutiveLawToPython() .def("CalculateMaterialResponsePK2",&ConstitutiveLaw::CalculateMaterialResponsePK2) .def("CalculateMaterialResponseKirchhoff",&ConstitutiveLaw::CalculateMaterialResponseKirchhoff) .def("CalculateMaterialResponseCauchy",&ConstitutiveLaw::CalculateMaterialResponseCauchy) + .def("InitializeMaterialResponse",&ConstitutiveLaw::InitializeMaterialResponse) + .def("InitializeMaterialResponsePK1",&ConstitutiveLaw::InitializeMaterialResponsePK1) + .def("InitializeMaterialResponsePK2",&ConstitutiveLaw::InitializeMaterialResponsePK2) + .def("InitializeMaterialResponseKirchhoff",&ConstitutiveLaw::InitializeMaterialResponseKirchhoff) + .def("InitializeMaterialResponseCauchy",&ConstitutiveLaw::InitializeMaterialResponseCauchy) .def("FinalizeMaterialResponse",&ConstitutiveLaw::FinalizeMaterialResponse) .def("FinalizeMaterialResponsePK1",&ConstitutiveLaw::FinalizeMaterialResponsePK1) .def("FinalizeMaterialResponsePK2",&ConstitutiveLaw::FinalizeMaterialResponsePK2) @@ -209,13 +214,16 @@ void AddConstitutiveLawToPython() .def("PushForwardConstitutiveMatrix",&ConstitutiveLaw::PushForwardConstitutiveMatrix) .def("Check",&ConstitutiveLaw::Check) .def("GetLawFeatures",&ConstitutiveLaw::GetLawFeatures) - .def_readonly("COMPUTE_STRAIN", &ConstitutiveLaw::COMPUTE_STRAIN) + .def_readonly("USE_ELEMENT_PROVIDED_STRAIN", &ConstitutiveLaw::USE_ELEMENT_PROVIDED_STRAIN) .def_readonly("COMPUTE_STRESS", &ConstitutiveLaw::COMPUTE_STRESS) .def_readonly("COMPUTE_CONSTITUTIVE_TENSOR", &ConstitutiveLaw::COMPUTE_CONSTITUTIVE_TENSOR) .def_readonly("COMPUTE_STRAIN_ENERGY", &ConstitutiveLaw::COMPUTE_STRAIN_ENERGY) .def_readonly("ISOCHORIC_TENSOR_ONLY", &ConstitutiveLaw::ISOCHORIC_TENSOR_ONLY) .def_readonly("VOLUMETRIC_TENSOR_ONLY", &ConstitutiveLaw::VOLUMETRIC_TENSOR_ONLY) - .def_readonly("TOTAL_TENSOR", &ConstitutiveLaw::TOTAL_TENSOR) + .def_readonly("MECHANICAL_RESPONSE_ONLY", &ConstitutiveLaw::MECHANICAL_RESPONSE_ONLY) + .def_readonly("THERMAL_RESPONSE_ONLY", &ConstitutiveLaw::THERMAL_RESPONSE_ONLY) + .def_readonly("INCREMENTAL_STRAIN_MEASURE", &ConstitutiveLaw::INCREMENTAL_STRAIN_MEASURE) + .def_readonly("INITIALIZE_MATERIAL_RESPONSE", &ConstitutiveLaw::INITIALIZE_MATERIAL_RESPONSE) .def_readonly("FINALIZE_MATERIAL_RESPONSE", &ConstitutiveLaw::FINALIZE_MATERIAL_RESPONSE) .def_readonly("FINITE_STRAINS", &ConstitutiveLaw::FINITE_STRAINS) .def_readonly("INFINITESIMAL_STRAINS", &ConstitutiveLaw::INFINITESIMAL_STRAINS) diff --git a/kratos/python/add_containers_to_python.cpp b/kratos/python/add_containers_to_python.cpp index 51dbdd60548b..8037234b2838 100644 --- a/kratos/python/add_containers_to_python.cpp +++ b/kratos/python/add_containers_to_python.cpp @@ -1,25 +1,14 @@ -// Kratos Multi-Physics +// | / | +// ' / __| _` | __| _ \ __| +// . \ | ( | | ( |\__ ` +// _|\_\_| \__,_|\__|\___/ ____/ +// Multi-Physics // -// Copyright (c) 2016 Pooyan Dadvand, Riccardo Rossi, CIMNE (International Center for Numerical Methods in Engineering) -// All rights reserved. +// License: BSD License +// Kratos default license: kratos/license.txt // -// Redistribution and use in source and binary forms, with or without modification, are permitted provided that the following conditions are met: +// Main authors: Pooyan Dadvand // -// - Redistributions of source code must retain the above copyright notice, this list of conditions and the following disclaimer. -// - Redistributions in binary form must reproduce the above copyright notice, this list of conditions and the following disclaimer -// in the documentation and/or other materials provided with the distribution. -// - All advertising materials mentioning features or use of this software must display the following acknowledgement: -// This product includes Kratos Multi-Physics technology. -// - Neither the name of the CIMNE nor the names of its contributors may be used to endorse or promote products derived from this software without specific prior written permission. -// -// THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS ''AS IS'' AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, -// THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE COPYRIGHT -// HOLDERS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, -// PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED ANDON ANY -// THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT(INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF -// THE USE OF THISSOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE. - - // System includes @@ -534,7 +523,7 @@ void AddContainersToPython() KRATOS_REGISTER_IN_PYTHON_VARIABLE( FLAG_VARIABLE ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( DISTANCE ) - KRATOS_REGISTER_IN_PYTHON_VARIABLE( DISTANCE_GRADIENT ) + KRATOS_REGISTER_IN_PYTHON_3D_VARIABLE_WITH_COMPONENTS( DISTANCE_GRADIENT ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( INERTIA ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( PERIODIC_PAIR_INDEX ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( PARTITION_INDEX ) @@ -584,6 +573,10 @@ void AddContainersToPython() KRATOS_REGISTER_IN_PYTHON_VARIABLE( PARTITION_MASK ) + // For MeshingApplication + KRATOS_REGISTER_IN_PYTHON_VARIABLE( NODAL_ERROR ) + KRATOS_REGISTER_IN_PYTHON_3D_VARIABLE_WITH_COMPONENTS( NODAL_ERROR_COMPONENTS ) + //for PFEM application TO BE REMOVED KRATOS_REGISTER_IN_PYTHON_VARIABLE( NODAL_AREA ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( NODAL_H ) @@ -708,6 +701,7 @@ void AddContainersToPython() KRATOS_REGISTER_IN_PYTHON_VARIABLE( SEARCH_RADIUS ) KRATOS_REGISTER_IN_PYTHON_VARIABLE( INTEGRATION_WEIGHT ) + KRATOS_REGISTER_IN_PYTHON_3D_VARIABLE_WITH_COMPONENTS( INTEGRATION_COORDINATES ) class_< ConvectionDiffusionSettings, ConvectionDiffusionSettings::Pointer, boost::noncopyable > ("ConvectionDiffusionSettings", init< >() ) diff --git a/kratos/python/add_mesh_to_python.cpp b/kratos/python/add_mesh_to_python.cpp index ce7bdcacb5de..299857704d02 100644 --- a/kratos/python/add_mesh_to_python.cpp +++ b/kratos/python/add_mesh_to_python.cpp @@ -1,15 +1,14 @@ -// | / | +// | / | // ' / __| _` | __| _ \ __| // . \ | ( | | ( |\__ ` // _|\_\_| \__,_|\__|\___/ ____/ -// Multi-Physics +// Multi-Physics // -// License: BSD License +// License: BSD License // Kratos default license: kratos/license.txt // -// Main authors: Riccardo Rossi -// Pooyan Dadvand -// +// Main authors: Pooyan Dadvand +// Riccardo Rossi // // System includes @@ -60,6 +59,22 @@ typedef MeshType::NodeType NodeType; typedef MeshType::NodesContainerType NodesContainerType; typedef Geometry >::PointsArrayType NodesArrayType; typedef Geometry >::IntegrationPointsArrayType IntegrationPointsArrayType; +typedef Point<3>::CoordinatesArrayType CoordinatesArrayType; + +array_1d GetNormalFromCondition( + Condition& dummy, + CoordinatesArrayType& LocalCoords + ) +{ + return( dummy.GetGeometry().Normal(LocalCoords) ); +} + +array_1d FastGetNormalFromCondition(Condition& dummy) +{ + CoordinatesArrayType LocalCoords; + LocalCoords.clear(); + return( dummy.GetGeometry().Normal(LocalCoords) ); +} double GetAreaFromCondition( Condition& dummy ) { @@ -145,6 +160,32 @@ boost::python::list GetIntegrationPointsFromElement( Element& dummy ) return( integration_points_list ); } +boost::python::list CalculateOnIntegrationPointsDouble( + Element& dummy, const Variable& rVariable, ProcessInfo& rProcessInfo ) +{ + std::vector Output; + dummy.CalculateOnIntegrationPoints( rVariable, Output, rProcessInfo); + boost::python::list result; + for( unsigned int j=0; j>& rVariable, ProcessInfo& rProcessInfo ) +{ + std::vector> Output; + dummy.CalculateOnIntegrationPoints( rVariable, Output, rProcessInfo); + boost::python::list result; + for( unsigned int j=0; j& rVariable, ProcessInfo& rProcessInfo ) { @@ -152,7 +193,9 @@ boost::python::list CalculateOnIntegrationPointsVector( dummy.CalculateOnIntegrationPoints( rVariable, Output, rProcessInfo); boost::python::list result; for( unsigned int j=0; j) @@ -542,7 +587,9 @@ void AddMeshToPython() //.def("SetValuesOnIntegrationPoints", SetValuesOnIntegrationPointsConstitutiveLaw) .def("SetValuesOnIntegrationPoints", SetValuesOnIntegrationPointsDouble) .def("SetValuesOnIntegrationPoints", SetValuesOnIntegrationPointsArray1d) - .def("GetArea",GetAreaFromCondition) + .def("GetNormal",GetNormalFromCondition) + .def("GetNormal",FastGetNormalFromCondition) + .def("GetArea",GetAreaFromCondition) diff --git a/kratos/python/add_model_part_to_python.cpp b/kratos/python/add_model_part_to_python.cpp index eb95b60d4287..f31e7eb75ac4 100644 --- a/kratos/python/add_model_part_to_python.cpp +++ b/kratos/python/add_model_part_to_python.cpp @@ -565,6 +565,15 @@ TDataType CommunicatorMaxAll(Communicator& rCommunicator, const TDataType& rValu return Value; } +template +TDataType CommunicatorScanSum(Communicator& rCommunicator, const TDataType rSendPartial, TDataType rReceiveAccumulated) +{ + TDataType SendPartial = rSendPartial; + TDataType ReceiveAccumulated = rReceiveAccumulated; + rCommunicator.ScanSum(SendPartial, ReceiveAccumulated); + return ReceiveAccumulated; +} + void AddModelPartToPython() { @@ -600,6 +609,8 @@ void AddModelPartToPython() .def("MinAll", CommunicatorMinAll ) .def("MaxAll", CommunicatorMaxAll ) .def("MaxAll", CommunicatorMaxAll ) + .def("ScanSum", CommunicatorScanSum ) + .def("ScanSum", CommunicatorScanSum ) .def("AssembleCurrentData", CommunicatorAssembleCurrentData ) .def("AssembleCurrentData", CommunicatorAssembleCurrentData ) .def("AssembleCurrentData", CommunicatorAssembleCurrentData > ) @@ -614,7 +625,7 @@ void AddModelPartToPython() - class_ >("ModelPart") + class_, boost::noncopyable >("ModelPart") .def(init()) .def(init<>()) .add_property("Name", GetModelPartName, SetModelPartName) diff --git a/kratos/python/add_modeler_to_python.cpp b/kratos/python/add_modeler_to_python.cpp index acca2643407e..b35e59841ccf 100644 --- a/kratos/python/add_modeler_to_python.cpp +++ b/kratos/python/add_modeler_to_python.cpp @@ -31,8 +31,7 @@ #include "add_modeler_to_python.h" #include "modeler/modeler.h" #include "modeler/edge_swapping_2d_modeler.h" -#include "modeler/mpi_connectivity_preserve_modeler.h" -//#include "sources/mpi_connectivity_preserve_modeler.cpp" +#include "modeler/connectivity_preserve_modeler.h" namespace Kratos @@ -70,7 +69,7 @@ void AddModelerToPython() .def(self_ns::str(self)) ; - class_,boost::noncopyable>("MPIConnectivityPreserveModeler") + class_,boost::noncopyable>("ConnectivityPreserveModeler") ; diff --git a/kratos/python/add_processes_to_python.cpp b/kratos/python/add_processes_to_python.cpp index 96002edca25e..067662f5f388 100644 --- a/kratos/python/add_processes_to_python.cpp +++ b/kratos/python/add_processes_to_python.cpp @@ -208,21 +208,41 @@ void AddProcessesToPython() init()) ; + /* Historical */ // DOUBLE - class_> , bases, boost::noncopyable >("ComputeNodalGradientProcess2D", + class_, Historical> , bases, boost::noncopyable >("ComputeNodalGradientProcess2D", init&, Variable >& , Variable& >()) ; - class_> , bases, boost::noncopyable >("ComputeNodalGradientProcess3D", + class_, Historical> , bases, boost::noncopyable >("ComputeNodalGradientProcess3D", init&, Variable >& , Variable& >()) ; // COMPONENT - class_ , bases, boost::noncopyable >("ComputeNodalGradientProcessComp2D", + class_ , bases, boost::noncopyable >("ComputeNodalGradientProcessComp2D", init >& , Variable& >()) ; - class_ , bases, boost::noncopyable >("ComputeNodalGradientProcessComp3D", + class_ , bases, boost::noncopyable >("ComputeNodalGradientProcessComp3D", + init >& , Variable& >()) + ; + + /* Non-Historical */ + // DOUBLE + class_, NonHistorical> , bases, boost::noncopyable >("ComputeNonHistoricalNodalGradientProcess2D", + init&, Variable >& , Variable& >()) + ; + + class_, NonHistorical> , bases, boost::noncopyable >("ComputeNonHistoricalNodalGradientProcess3D", + init&, Variable >& , Variable& >()) + ; + + // COMPONENT + class_ , bases, boost::noncopyable >("ComputeNonHistoricalNodalGradientProcessComp2D", + init >& , Variable& >()) + ; + + class_ , bases, boost::noncopyable >("ComputeNonHistoricalNodalGradientProcessComp3D", init >& , Variable& >()) ; diff --git a/kratos/python/add_utilities_to_python.cpp b/kratos/python/add_utilities_to_python.cpp index 7e16ae3a46eb..00d2f7501f21 100644 --- a/kratos/python/add_utilities_to_python.cpp +++ b/kratos/python/add_utilities_to_python.cpp @@ -45,7 +45,6 @@ #include "utilities/binbased_fast_point_locator.h" #include "utilities/binbased_nodes_in_element_locator.h" #include "utilities/geometry_tester.h" -#include "utilities/connectivity_preserve_modeler.h" #include "utilities/cutting_utility.h" #include "utilities/python_function_callback_utility.h" @@ -58,23 +57,6 @@ namespace Python { - - -void GenerateModelPart(ConnectivityPreserveModeler& GM, ModelPart& origin_model_part, ModelPart& destination_model_part, const char* ElementName, const char* ConditionName) -{ - if( !KratosComponents< Element >::Has( ElementName ) ) - KRATOS_THROW_ERROR(std::invalid_argument, "Element name not found in KratosComponents< Element > -- name is ", ElementName); - if( !KratosComponents< Condition >::Has( ConditionName ) ) - KRATOS_THROW_ERROR(std::invalid_argument, "Condition name not found in KratosComponents< Condition > -- name is ", ConditionName); - - GM.GenerateModelPart(origin_model_part, destination_model_part, - KratosComponents::Get(ElementName), - KratosComponents::Get(ConditionName)); - -} - - - void AddUtilitiesToPython() { using namespace boost::python; @@ -321,10 +303,6 @@ void AddUtilitiesToPython() .def("TestHexahedra3D20N", &GeometryTesterUtility::TestHexahedra3D20N) ; - class_ ("ConnectivityPreserveModeler", init< >()) - .def("GenerateModelPart", GenerateModelPart) - ; - class_("CuttingUtility", init< >()) .def("GenerateCut", &CuttingUtility::GenerateCut) .def("UpdateCutData", &CuttingUtility ::UpdateCutData) diff --git a/kratos/python_scripts/compare_two_files_check_process.py b/kratos/python_scripts/compare_two_files_check_process.py index 780a8b8ddd22..bb13c5e4d8e3 100644 --- a/kratos/python_scripts/compare_two_files_check_process.py +++ b/kratos/python_scripts/compare_two_files_check_process.py @@ -65,18 +65,25 @@ def ExecuteFinalize(self): if (self.non_deterministic_comp == "mesh_file"): error = _ReadVertices(self.file_name_1, self.file_name_2, self.dimension) self.assertTrue(error < self.error_assumed) + elif (self.non_deterministic_comp == "sol_file"): + error = _ReadMetric(self.file_name_1, self.file_name_2, self.dimension) + self.assertTrue(error < self.error_assumed) else: raise NameError('Non-deterministic comparision not implemented yet') -def _ConvertStringToListFloat(line): +def _ConvertStringToListFloat(line, space = " ", endline = ""): list_values = [] - value = "" - for i in line: - if (i == " "): - list_values.append(float(value)) - value = "" - else: - value += i + string_values = (line.replace(endline,"")).split(space) + for string in string_values: + list_values.append(float(string)) + #value = "" + #for i in line: + #if ((i == " ") or (i == " ")): + #num_value = float(value) + #list_values.append(num_value) + #value = "" + #else: + #value += i return list_values def _ReadVertices(input_file1, input_file2, dimension): @@ -98,8 +105,8 @@ def _ReadVertices(input_file1, input_file2, dimension): error = 0.0 for i in range(numline, nvertices + numline): - tmp1 = _ConvertStringToListFloat(lines1[i]) - tmp2 = _ConvertStringToListFloat(lines2[i]) + tmp1 = _ConvertStringToListFloat(lines1[i], "", "\n") + tmp2 = _ConvertStringToListFloat(lines2[i], "", "\n") if (dimension == 2): error += ((tmp1[0] - tmp2[0])**2.0 + (tmp1[1] - tmp2[1])**2.0)**(0.5) else: @@ -109,3 +116,43 @@ def _ReadVertices(input_file1, input_file2, dimension): f2.close() return (error/nvertices) + +def _ReadMetric(input_file1, input_file2, dimension): + f1 = open(input_file1,'r') + f2 = open(input_file2,'r') + + lines1 = f1.readlines() + lines2 = f2.readlines() + + numline = 0 + for line1 in lines1: + numline += 1 + + if("SolAtVertices" in line1): + line = lines1[numline] + nvertices = int(line) + numline += 2 + break + + error = 0.0 + for i in range(numline, nvertices + numline): + + if dimension == 2: + space = " " + end_line = " \n" + else: + space = " " + end_line = " \n" + + tmp1 = _ConvertStringToListFloat(lines1[i], space, end_line) + tmp2 = _ConvertStringToListFloat(lines2[i], space, end_line) + + if (dimension == 2): + error += ((tmp1[0] - tmp2[0])**2.0 + (tmp1[1] - tmp2[1])**2.0 + (tmp1[2] - tmp2[2])**2.0)**(0.5) + else: + error += ((tmp1[0] - tmp2[0])**2.0 + (tmp1[1] - tmp2[1])**2.0 + (tmp1[2] - tmp2[2])**2.0 + (tmp1[3] - tmp2[3])**2.0 + (tmp1[4] - tmp2[4])**2.0 + (tmp1[5] - tmp2[5])**2.0)**(0.5) + + f1.close() + f2.close() + + return (error/nvertices) diff --git a/kratos/python_scripts/from_json_check_result_process.py b/kratos/python_scripts/from_json_check_result_process.py index 8ce590389c6f..f1494a4b5401 100644 --- a/kratos/python_scripts/from_json_check_result_process.py +++ b/kratos/python_scripts/from_json_check_result_process.py @@ -86,7 +86,8 @@ def ExecuteFinalizeSolutionStep(self): value_json = self.__linear_interpolation(time, input_time_list, values_json) if (self.iscloseavailable == True): isclosethis = math.isclose(value, value_json, rel_tol=reltol, abs_tol=tol) - self.assertTrue(isclosethis) + self.assertTrue(isclosethis, msg=(str(value)+" != "+str(value_json)+", rel_tol = "+str(reltol)+", abs_tol = "+str(tol)+ + " : Error checking node "+str(node.Id)+" "+out.GetString()+" results.")) else: self.assertAlmostEqual(value, value_json, msg=("Error checking node "+str(node.Id)+" "+out.GetString()+" results."), delta=tol) # Vector variable @@ -97,17 +98,20 @@ def ExecuteFinalizeSolutionStep(self): values_json = self.data["NODE_"+str(node.Id)][out.GetString() + "_X"] value_json = self.__linear_interpolation(time, input_time_list, values_json) isclosethis = math.isclose(value[0], value_json, rel_tol=reltol, abs_tol=tol) - self.assertTrue(isclosethis) + self.assertTrue(isclosethis, msg=(str(value)+" != "+str(value_json)+", rel_tol = "+str(reltol)+", abs_tol = "+str(tol)+ + " : Error checking node "+str(node.Id)+" "+out.GetString()+" results.")) # Y-component values_json = self.data["NODE_"+str(node.Id)][out.GetString() + "_Y"] value_json = self.__linear_interpolation(time, input_time_list, values_json) isclosethis = math.isclose(value[1], value_json, rel_tol=reltol, abs_tol=tol) - self.assertTrue(isclosethis) + self.assertTrue(isclosethis, msg=(str(value)+" != "+str(value_json)+", rel_tol = "+str(reltol)+", abs_tol = "+str(tol)+ + " : Error checking node "+str(node.Id)+" "+out.GetString()+" results.")) # Z-component values_json = self.data["NODE_"+str(node.Id)][out.GetString() + "_Z"] value_json = self.__linear_interpolation(time, input_time_list, values_json) isclosethis = math.isclose(value[2], value_json, rel_tol=reltol, abs_tol=tol) - self.assertTrue(isclosethis) + self.assertTrue(isclosethis, msg=(str(value)+" != "+str(value_json)+", rel_tol = "+str(reltol)+", abs_tol = "+str(tol)+ + " : Error checking node "+str(node.Id)+" "+out.GetString()+" results.")) else: # X-component values_json = self.data["NODE_"+str(node.Id)][out.GetString() + "_X"] @@ -127,7 +131,8 @@ def ExecuteFinalizeSolutionStep(self): value_json = self.__linear_interpolation(time, input_time_list, values_json[index]) if (self.iscloseavailable == True): isclosethis = math.isclose(value[index], value_json, rel_tol=reltol, abs_tol=tol) - self.assertTrue(isclosethis) + self.assertTrue(isclosethis, msg=(str(value)+" != "+str(value_json)+", rel_tol = "+str(reltol)+", abs_tol = "+str(tol)+ + " : Error checking node "+str(node.Id)+" "+out.GetString()+" results.")) else: self.assertAlmostEqual(value[index], value_json, msg=("Error checking node "+str(node.Id)+" "+out.GetString()+" results."), delta=tol) @@ -154,4 +159,4 @@ def __generate_variable_list_from_input(self,param): raise Exception("{0} Error: Variable list is unreadable".format(self.__class__.__name__)) # Retrieve variable name from input (a string) and request the corresponding C++ object to the kernel - return [ KratosMultiphysics.KratosGlobals.GetVariable( param[i].GetString() ) for i in range( 0,param.size() ) ] + return [ KratosMultiphysics.KratosGlobals.GetVariable( param[i].GetString() ) for i in range( 0,param.size() ) ] \ No newline at end of file diff --git a/kratos/solving_strategies/strategies/solving_strategy.h b/kratos/solving_strategies/strategies/solving_strategy.h index 986e87b42caa..0fb9d2294f3d 100644 --- a/kratos/solving_strategies/strategies/solving_strategy.h +++ b/kratos/solving_strategies/strategies/solving_strategy.h @@ -2,13 +2,13 @@ // ' / __| _` | __| _ \ __| // . \ | ( | | ( |\__ ` // _|\_\_| \__,_|\__|\___/ ____/ -// Multi-Physics +// Multi-Physics // -// License: BSD License +// License: BSD License // Kratos default license: kratos/license.txt // // Main authors: Riccardo Rossi -// +// // #if !defined(KRATOS_SOLVING_STRATEGY ) @@ -77,50 +77,50 @@ class SolvingStrategy public: ///@name Type Definitions ///@{ - + // typedef std::set DofSetType; typedef typename TSparseSpace::DataType TDataType; - + typedef typename TSparseSpace::MatrixType TSystemMatrixType; - + typedef typename TSparseSpace::VectorType TSystemVectorType; typedef typename TSparseSpace::MatrixPointerType TSystemMatrixPointerType; - + typedef typename TSparseSpace::VectorPointerType TSystemVectorPointerType; typedef typename TDenseSpace::MatrixType LocalSystemMatrixType; - + typedef typename TDenseSpace::VectorType LocalSystemVectorType; typedef Scheme TSchemeType; - + typedef BuilderAndSolver TBuilderAndSolverType; typedef typename ModelPart::DofType TDofType; - + typedef typename ModelPart::DofsArrayType DofsArrayType; - + // typedef Dof TDofType; - + // typedef PointerVectorSet > DofsArrayType; - + // typedef PointerVectorSet DofsArrayType; - + typedef typename DofsArrayType::iterator DofIteratorType; - + typedef typename DofsArrayType::const_iterator DofConstantIteratorType; - + typedef ModelPart::NodesContainerType NodesArrayType; - + typedef ModelPart::ElementsContainerType ElementsArrayType; - + typedef ModelPart::ConditionsContainerType ConditionsArrayType; - + /** Counted pointer of ClassName */ KRATOS_CLASS_POINTER_DEFINITION(SolvingStrategy); - + ///@} ///@name Life Cycle ///@{ @@ -131,14 +131,14 @@ class SolvingStrategy */ SolvingStrategy( - ModelPart& rModelPart, + ModelPart& rModelPart, bool MoveMeshFlag = false ) : mrModelPart(rModelPart) { SetMoveMeshFlag(MoveMeshFlag); } - + ///@} /** Destructor. @@ -146,11 +146,11 @@ class SolvingStrategy ///@{ virtual ~SolvingStrategy(){} - + ///@} /**OPERATIONS ACCESSIBLE FROM THE INPUT:*/ - + ///@{ /** @@ -166,7 +166,6 @@ class SolvingStrategy */ virtual void Initialize() { - KRATOS_ERROR << "You are calling to the base class method Initialize, please define in you derived class the method" << std::endl; } /** @@ -181,9 +180,9 @@ class SolvingStrategy Predict(); SolveSolutionStep(); FinalizeSolutionStep(); - - return 0.0; - + + return 0.0; + } /** @@ -191,7 +190,6 @@ class SolvingStrategy */ virtual void Clear() { - KRATOS_ERROR << "You are calling to the base class method Clear, please define in you derived class the method" << std::endl; } /** @@ -316,20 +314,20 @@ class SolvingStrategy if (GetModelPart().NodesBegin()->SolutionStepsDataHas(DISPLACEMENT_X) == false) { KRATOS_ERROR << "It is impossible to move the mesh since the DISPLACEMENT var is not in the Model Part. Either use SetMoveMeshFlag(False) or add DISPLACEMENT to the list of variables" << std::endl; - } + } NodesArrayType& NodesArray = GetModelPart().Nodes(); const int numNodes = static_cast(NodesArray.size()); #pragma omp parallel for - for(int i = 0; i < numNodes; i++) + for(int i = 0; i < numNodes; i++) { auto itNode = NodesArray.begin() + i; noalias(itNode->Coordinates()) = itNode->GetInitialPosition().Coordinates(); noalias(itNode->Coordinates()) += itNode->FastGetSolutionStepValue(DISPLACEMENT); } - + if (this->GetEchoLevel() != 0 && GetModelPart().GetCommunicator().MyPID() == 0 ) { std::cout<<" MESH MOVED "<Check(GetModelPart().GetProcessInfo()); } - + return 0; - + KRATOS_CATCH("") } @@ -496,4 +494,3 @@ class SolvingStrategy } /* namespace Kratos.*/ #endif /* KRATOS_SOLVING_STRATEGY defined */ - diff --git a/kratos/sources/connectivity_preserve_modeler.cpp b/kratos/sources/connectivity_preserve_modeler.cpp new file mode 100644 index 000000000000..8c3a1bf7dda7 --- /dev/null +++ b/kratos/sources/connectivity_preserve_modeler.cpp @@ -0,0 +1,231 @@ +// | / | +// ' / __| _` | __| _ \ __| +// . \ | ( | | ( |\__ ` +// _|\_\_| \__,_|\__|\___/ ____/ +// Multi-Physics +// +// License: BSD License +// Kratos default license: kratos/license.txt +// +// Main authors: Riccardo Rossi +// +// + +#include "modeler/connectivity_preserve_modeler.h" + +namespace Kratos +{ + +// Public methods ////////////////////////////////////////////////////////////// + +ConnectivityPreserveModeler::ConnectivityPreserveModeler(): + Modeler() +{ +} + + +ConnectivityPreserveModeler::~ConnectivityPreserveModeler() +{ +} + + +void ConnectivityPreserveModeler::GenerateModelPart( + ModelPart& rOriginModelPart, + ModelPart& rDestinationModelPart, + Element const& rReferenceElement, + Condition const& rReferenceBoundaryCondition) +{ + KRATOS_TRY; + + this->ResetModelPart(rDestinationModelPart); + + this->CopyCommonData(rOriginModelPart, rDestinationModelPart); + + this->DuplicateElements(rOriginModelPart, rDestinationModelPart, rReferenceElement); + + this->DuplicateConditions(rOriginModelPart, rDestinationModelPart, rReferenceBoundaryCondition); + + this->DuplicateCommunicatorData(rOriginModelPart,rDestinationModelPart); + + this->DuplicateSubModelParts(rOriginModelPart, rDestinationModelPart); + + KRATOS_CATCH(""); +} + +// Private methods ///////////////////////////////////////////////////////////// + +void ConnectivityPreserveModeler::ResetModelPart(ModelPart &rDestinationModelPart) +{ + for(auto it = rDestinationModelPart.NodesBegin(); it != rDestinationModelPart.NodesEnd(); it++) + it->Set(TO_ERASE); + rDestinationModelPart.RemoveNodes(TO_ERASE); + + for(auto it = rDestinationModelPart.ElementsBegin(); it != rDestinationModelPart.ElementsEnd(); it++) + it->Set(TO_ERASE); + rDestinationModelPart.RemoveElements(TO_ERASE); + + for(auto it = rDestinationModelPart.ElementsBegin(); it != rDestinationModelPart.ElementsEnd(); it++) + it->Set(TO_ERASE); + rDestinationModelPart.RemoveConditions(TO_ERASE); +} + + +void ConnectivityPreserveModeler::CopyCommonData( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart) +{ + // Do not try to change some of the things we need to change if the destination is a SubModelPart + if( rDestinationModelPart.IsSubModelPart() ) + { + if( !(rOriginModelPart.GetNodalSolutionStepVariablesList() == rDestinationModelPart.GetNodalSolutionStepVariablesList()) ) + { + KRATOS_ERROR << "Attempting to change the SolutionStepVariablesList of the Destination Model Part, which is a SubModelPart." << std::endl + << "Aborting, since this would break its parent ModelPart." << std::endl; + } + + if( rDestinationModelPart.GetBufferSize() != rOriginModelPart.GetBufferSize() ) + { + KRATOS_ERROR << "Attempting to change the BufferSize of the Destination Model Part, which is a SubModelPart." << std::endl + << "Aborting, since this would break its parent ModelPart." << std::endl; + } + } + else + { + rDestinationModelPart.GetNodalSolutionStepVariablesList() = rOriginModelPart.GetNodalSolutionStepVariablesList(); + rDestinationModelPart.SetBufferSize( rOriginModelPart.GetBufferSize() ); + } + + // These should be safe for SubModelParts + rDestinationModelPart.SetProcessInfo( rOriginModelPart.pGetProcessInfo() ); + rDestinationModelPart.SetProperties( rOriginModelPart.pProperties() ); + rDestinationModelPart.Tables() = rOriginModelPart.Tables(); + + // Assign the nodes to the new model part + rDestinationModelPart.AddNodes(rOriginModelPart.NodesBegin(), rOriginModelPart.NodesEnd()); +} + + +void ConnectivityPreserveModeler::DuplicateElements( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart, + Element const &rReferenceElement) +{ + // Generate the elements + ModelPart::ElementsContainerType temp_elements; + temp_elements.reserve(rOriginModelPart.NumberOfElements()); + for (auto i_elem = rOriginModelPart.ElementsBegin(); i_elem != rOriginModelPart.ElementsEnd(); ++i_elem) + { + Properties::Pointer properties = i_elem->pGetProperties(); + Element::Pointer p_element = rReferenceElement.Create(i_elem->Id(), i_elem->GetGeometry(), properties); + + // Reuse the geometry of the old element (to save memory) + p_element->pGetGeometry() = i_elem->pGetGeometry(); + + temp_elements.push_back(p_element); + } + + rDestinationModelPart.AddElements(temp_elements.begin(), temp_elements.end()); +} + + +void ConnectivityPreserveModeler::DuplicateConditions( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart, + Condition const &rReferenceBoundaryCondition) +{ + // Generate the conditions + ModelPart::ConditionsContainerType temp_conditions; + temp_conditions.reserve(rOriginModelPart.NumberOfConditions()); + for (auto i_cond = rOriginModelPart.ConditionsBegin(); i_cond != rOriginModelPart.ConditionsEnd(); ++i_cond) + { + Properties::Pointer properties = i_cond->pGetProperties(); + Condition::Pointer p_condition = rReferenceBoundaryCondition.Create(i_cond->Id(), i_cond->GetGeometry(), properties); + + // Reuse the geometry of the old element (to save memory) + p_condition->pGetGeometry() = i_cond->pGetGeometry(); + + temp_conditions.push_back(p_condition); + } + + rDestinationModelPart.AddConditions(temp_conditions.begin(), temp_conditions.end()); +} + +void ConnectivityPreserveModeler::DuplicateCommunicatorData( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart) +{ + /* Create a new communicator for rDestinationModelPart and fill it with the information of the original one + * Only "general" information and node lists are copied, element and condition lists will be created later + * using the new elements. + */ + Communicator& rReferenceComm = rOriginModelPart.GetCommunicator(); + Communicator::Pointer pDestinationComm = rReferenceComm.Create(); + pDestinationComm->SetNumberOfColors( rReferenceComm.GetNumberOfColors() ); + pDestinationComm->NeighbourIndices() = rReferenceComm.NeighbourIndices(); + pDestinationComm->LocalMesh().SetNodes( rReferenceComm.LocalMesh().pNodes() ); + pDestinationComm->InterfaceMesh().SetNodes( rReferenceComm.InterfaceMesh().pNodes() ); + pDestinationComm->GhostMesh().SetNodes( rReferenceComm.GhostMesh().pNodes() ); + for (unsigned int i = 0; i < rReferenceComm.GetNumberOfColors(); i++) + { + pDestinationComm->pLocalMesh(i)->SetNodes( rReferenceComm.pLocalMesh(i)->pNodes() ); + pDestinationComm->pInterfaceMesh(i)->SetNodes( rReferenceComm.pInterfaceMesh(i)->pNodes() ); + pDestinationComm->pGhostMesh(i)->SetNodes( rReferenceComm.pGhostMesh(i)->pNodes() ); + } + + // This is a dirty hack to detect if the communicator is a Communicator or an MPICommunicator + // Note that downcasting would not work here because MPICommunicator is not compiled in non-MPI builds + bool is_mpi = ( rOriginModelPart.pElements() == rReferenceComm.LocalMesh().pElements() ); + + if (is_mpi) + { + // All elements are passed as local elements to the new communicator + ModelPart::ElementsContainerType& rDestinationLocalElements = pDestinationComm->LocalMesh().Elements(); + rDestinationLocalElements.clear(); + rDestinationLocalElements.reserve(rDestinationModelPart.NumberOfElements()); + for (auto i_elem = rDestinationModelPart.Elements().ptr_begin(); i_elem != rDestinationModelPart.Elements().ptr_end(); ++i_elem) + { + rDestinationLocalElements.push_back(*i_elem); + } + + // Do the same for Conditions + ModelPart::ConditionsContainerType& rDestinationLocalConditions = pDestinationComm->LocalMesh().Conditions(); + rDestinationLocalConditions.clear(); + rDestinationLocalConditions.reserve(rDestinationModelPart.NumberOfConditions()); + for (auto i_cond = rDestinationModelPart.Conditions().ptr_begin(); i_cond != rDestinationModelPart.Conditions().ptr_end(); ++i_cond) + { + rDestinationLocalConditions.push_back(*i_cond); + } + } + else + { + pDestinationComm->LocalMesh().pElements() = rDestinationModelPart.pElements(); + pDestinationComm->LocalMesh().pConditions() = rDestinationModelPart.pConditions(); + } + + rDestinationModelPart.SetCommunicator( pDestinationComm ); +} + + +void ConnectivityPreserveModeler::DuplicateSubModelParts( + ModelPart &rOriginModelPart, + ModelPart &rDestinationModelPart) +{ + for(auto i_part = rOriginModelPart.SubModelPartsBegin(); i_part != rOriginModelPart.SubModelPartsEnd(); ++i_part) + { + auto& destination_part = rDestinationModelPart.CreateSubModelPart(i_part->Name()); + + destination_part.AddNodes(i_part->NodesBegin(), i_part->NodesEnd()); + + destination_part.AddElements(i_part->ElementsBegin(), i_part->ElementsEnd()); + + destination_part.AddConditions(i_part->ConditionsBegin(), i_part->ConditionsEnd()); + + // Duplicate the Communicator for this SubModelPart + this->DuplicateCommunicatorData(*i_part, destination_part); + + // Recursively call this function to duplicate any child SubModelParts + this->DuplicateSubModelParts(*i_part, destination_part); + } +} + +} diff --git a/kratos/sources/constitutive_law.cpp b/kratos/sources/constitutive_law.cpp index a2a322c2be03..3231e8007f00 100644 --- a/kratos/sources/constitutive_law.cpp +++ b/kratos/sources/constitutive_law.cpp @@ -1,1515 +1,1649 @@ -// | / | -// ' / __| _` | __| _ \ __| -// . \ | ( | | ( |\__ \. -// _|\_\_| \__,_|\__|\___/ ____/ -// Multi-Physics -// -// License: BSD License -// Kratos default license: kratos/license.txt -// -// Main authors: Riccardo Rossi -// Janosch Stascheit -// Nelson Maireni Lafontaine -// Josep Maria Carbonell -// - -#include "includes/constitutive_law.h" - - -namespace Kratos -{ -const unsigned int ConstitutiveLaw::msIndexVoigt3D6C [6][2] = { {0, 0}, {1, 1}, {2, 2}, {0, 1}, {1, 2}, {0, 2} }; -const unsigned int ConstitutiveLaw::msIndexVoigt2D4C [4][2] = { {0, 0}, {1, 1}, {2, 2}, {0, 1} }; -const unsigned int ConstitutiveLaw::msIndexVoigt2D3C [3][2] = { {0, 0}, {1, 1}, {0, 1} }; - -/** - * Flags related to the Parameters of the Contitutive Law - */ -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, COMPUTE_STRAIN, 0 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, COMPUTE_STRESS, 1 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, COMPUTE_CONSTITUTIVE_TENSOR, 2 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, COMPUTE_STRAIN_ENERGY, 3 ); - -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, ISOCHORIC_TENSOR_ONLY, 4 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, VOLUMETRIC_TENSOR_ONLY, 5 ); - -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, TOTAL_TENSOR, 6 ); - -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, FINALIZE_MATERIAL_RESPONSE, 7 ); - - -/** - * Flags related to the Features of the Contitutive Law - */ -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, FINITE_STRAINS, 8 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, INFINITESIMAL_STRAINS, 9 ); - -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, THREE_DIMENSIONAL_LAW, 10 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, PLANE_STRAIN_LAW, 11 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, PLANE_STRESS_LAW, 12 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, AXISYMMETRIC_LAW, 13 ); - -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, U_P_LAW, 14 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, ISOTROPIC, 15 ); -KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, ANISOTROPIC, 16 ); - - -/** - * Constructor. - */ -ConstitutiveLaw::ConstitutiveLaw() : Flags() -{ -} - - -/** - * Clone function (has to be implemented by any derived class) - * @return a pointer to a new instance of this constitutive law - * NOTE: implementation scheme: - * ConstitutiveLaw::Pointer p_clone(new ConstitutiveLaw()); - * return p_clone; - */ -ConstitutiveLaw::Pointer ConstitutiveLaw::Clone() const -{ - KRATOS_ERROR << "Called the virtual function for Clone"<< std::endl;; -} - -/** - * @return the working space dimension of the current constitutive law - * NOTE: this function HAS TO BE IMPLEMENTED by any derived class - */ -ConstitutiveLaw::SizeType ConstitutiveLaw::WorkingSpaceDimension() -{ - KRATOS_ERROR << "Called the virtual function for WorkingSpaceDimension"<< std::endl;; -} - -/** - * returns the size of the strain vector of the current constitutive law - * NOTE: this function HAS TO BE IMPLEMENTED by any derived class - */ -ConstitutiveLaw::SizeType ConstitutiveLaw::GetStrainSize() -{ - KRATOS_ERROR << "Called the virtual function for GetStrainSize"<< std::endl;; -} - -/** - * returns whether this constitutive Law has specified variable - * @param rThisVariable the variable to be checked for - * @return true if the variable is defined in the constitutive law - */ -bool ConstitutiveLaw::Has(const Variable& rThisVariable) -{ - return false; -} - -/** - * returns whether this constitutive Law has specified variable - * @param rThisVariable the variable to be checked for - * @return true if the variable is defined in the constitutive law - */ -bool ConstitutiveLaw::Has(const Variable& rThisVariable) -{ - return false; -} - -/** - * returns whether this constitutive Law has specified variable - * @param rThisVariable the variable to be checked for - * @return true if the variable is defined in the constitutive law - */ -bool ConstitutiveLaw::Has(const Variable& rThisVariable) -{ - return false; -} - -/** - * returns whether this constitutive Law has specified variable - * @param rThisVariable the variable to be checked for - * @return true if the variable is defined in the constitutive law - */ -bool ConstitutiveLaw::Has(const Variable& rThisVariable) -{ - return false; -} - -/** - * returns whether this constitutive Law has specified variable - * @param rThisVariable the variable to be checked for - * @return true if the variable is defined in the constitutive law - * NOTE: fixed size array of 3 doubles (e.g. for 2D stresses, plastic strains, ...) - */ -bool ConstitutiveLaw::Has(const Variable >& rThisVariable) -{ - return false; -} - -/** - * returns whether this constitutive Law has specified variable - * @param rThisVariable the variable to be checked for - * @return true if the variable is defined in the constitutive law - * NOTE: fixed size array of 6 doubles (e.g. for stresses, plastic strains, ...) - */ -bool ConstitutiveLaw::Has(const Variable >& rThisVariable) -{ - return false; -} - -/** - * returns the value of a specified variable - * @param rThisVariable the variable to be returned - * @param rValue a reference to the returned value - * @param rValue output: the value of the specified variable - */ -int& ConstitutiveLaw::GetValue(const Variable& rThisVariable, int& rValue) -{ - return rValue; -} - -/** - * returns the value of a specified variable - * @param rThisVariable the variable to be returned - * @param rValue a reference to the returned value - * @param rValue output: the value of the specified variable - */ -double& ConstitutiveLaw::GetValue(const Variable& rThisVariable, double& rValue) -{ - return rValue; -} - -/** - * returns the value of a specified variable - * @param rThisVariable the variable to be returned - * @param rValue a reference to the returned value - * @return the value of the specified variable - */ -Vector& ConstitutiveLaw::GetValue(const Variable& rThisVariable, Vector& rValue) -{ - return rValue; -} - -/** - * returns the value of a specified variable - * @param rThisVariable the variable to be returned - * @return the value of the specified variable - */ -Matrix& ConstitutiveLaw::GetValue(const Variable& rThisVariable, Matrix& rValue) -{ - return rValue; -} - -/** - * returns the value of a specified variable - * @param rThisVariable the variable to be returned - * @param rValue a reference to the returned value - * @return the value of the specified variable - */ -array_1d & ConstitutiveLaw::GetValue(const Variable >& rVariable, - array_1d & rValue) -{ - return rValue; -} - -/** - * returns the value of a specified variable - * @param rThisVariable the variable to be returned - * @param rValue a reference to the returned value - * @return the value of the specified variable - */ -array_1d & ConstitutiveLaw::GetValue(const Variable >& rVariable, - array_1d & rValue) -{ - return rValue; -} - -/** - * sets the value of a specified variable - * @param rVariable the variable to be returned - * @param Value new value of the specified variable - * @param rCurrentProcessInfo the process info - */ -void ConstitutiveLaw::SetValue(const Variable& rVariable, - const int& Value, - const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; -} - -/** - * sets the value of a specified variable - * @param rVariable the variable to be returned - * @param rValue new value of the specified variable - * @param rCurrentProcessInfo the process info - */ -void ConstitutiveLaw::SetValue(const Variable& rVariable, - const double& rValue, - const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; -} - -/** - * sets the value of a specified variable - * @param rVariable the variable to be returned - * @param rValue new value of the specified variable - * @param rCurrentProcessInfo the process info - */ -void ConstitutiveLaw::SetValue(const Variable& rVariable, - const Vector& rValue, const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; -} - -/** - * sets the value of a specified variable - * @param rVariable the variable to be returned - * @param rValue new value of the specified variable - * @param rCurrentProcessInfo the process info - */ -void ConstitutiveLaw::SetValue(const Variable& rVariable, - const Matrix& rValue, const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; -} - -/** - * sets the value of a specified variable - * @param rVariable the variable to be returned - * @param rValue new value of the specified variable - * @param rCurrentProcessInfo the process info - */ -void ConstitutiveLaw::SetValue(const Variable >& rVariable, - const array_1d & rValue, - const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; -} - -/** - * sets the value of a specified variable - * @param rVariable the variable to be returned - * @param rValue new value of the specified variable - * @param rCurrentProcessInfo the process info - */ -void ConstitutiveLaw::SetValue(const Variable >& rVariable, - const array_1d & rValue, - const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; -} - -/** - * Is called to check whether the provided material parameters in the Properties - * match the requirements of current constitutive model. - * @param rMaterialProperties the current Properties to be validated against. - * @return true, if parameters are correct; false, if parameters are insufficient / faulty - * NOTE: this has to implemented by each constitutive model. Returns false in base class since - * no valid implementation is contained here. - */ -bool ConstitutiveLaw::ValidateInput(const Properties& rMaterialProperties) -{ - return false; -} - -/** - * returns the expected strain measure of this constitutive law (by default linear strains) - * @return the expected strain measure - */ -ConstitutiveLaw::StrainMeasure ConstitutiveLaw::GetStrainMeasure() -{ - return StrainMeasure_Infinitesimal; -} - -/** - * returns the stress measure of this constitutive law (by default 1st Piola-Kirchhoff stress in voigt notation) - * @return the expected stress measure - */ -ConstitutiveLaw::StressMeasure ConstitutiveLaw::GetStressMeasure() -{ - return StressMeasure_PK1; -} - -/** - * returns whether this constitutive model is formulated in incremental strains/stresses - * NOTE: by default, all constitutive models should be formulated in total strains - * @return true, if formulated in incremental strains/stresses, false otherwise - */ -bool ConstitutiveLaw::IsIncremental() -{ - return false; -} - -/** - * This is to be called at the very beginning of the calculation - * (e.g. from InitializeElement) in order to initialize all relevant - * attributes of the constitutive law - * @param rMaterialProperties the Properties instance of the current element - * @param rElementGeometry the geometry of the current element - * @param rShapeFunctionsValues the shape functions values in the current integration point - */ -void ConstitutiveLaw::InitializeMaterial(const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, - const Vector& rShapeFunctionsValues) -{ -} - -/** - * to be called at the beginning of each solution step - * (e.g. from Element::InitializeSolutionStep) - * @param rMaterialProperties the Properties instance of the current element - * @param rElementGeometry the geometry of the current element - * @param rShapeFunctionsValues the shape functions values in the current integration point - * @param the current ProcessInfo instance - */ -void ConstitutiveLaw::InitializeSolutionStep(const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, //this is just to give the array of nodes - const Vector& rShapeFunctionsValues, - const ProcessInfo& rCurrentProcessInfo) -{ -} - -/** - * to be called at the end of each solution step - * (e.g. from Element::FinalizeSolutionStep) - * @param rMaterialProperties the Properties instance of the current element - * @param rElementGeometry the geometry of the current element - * @param rShapeFunctionsValues the shape functions values in the current integration point - * @param the current ProcessInfo instance - */ -void ConstitutiveLaw::FinalizeSolutionStep(const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, - const Vector& rShapeFunctionsValues, - const ProcessInfo& rCurrentProcessInfo) -{ -} - -/** - * to be called at the beginning of each step iteration - * (e.g. from Element::InitializeNonLinearIteration) - * @param rMaterialProperties the Properties instance of the current element - * @param rElementGeometry the geometry of the current element - * @param rShapeFunctionsValues the shape functions values in the current integration point - * @param the current ProcessInfo instance - */ -void ConstitutiveLaw::InitializeNonLinearIteration(const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, - const Vector& rShapeFunctionsValues, - const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_ERROR << "Calling virtual function for InitializeNonLinearIteration"<< std::endl;; -} - - - -/** - * to be called at the end of each step iteration - * (e.g. from Element::FinalizeNonLinearIteration) - * @param rMaterialProperties the Properties instance of the current element - * @param rElementGeometry the geometry of the current element - * @param rShapeFunctionsValues the shape functions values in the current integration point - * @param the current ProcessInfo instance - */ -void ConstitutiveLaw::FinalizeNonLinearIteration(const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, - const Vector& rShapeFunctionsValues, - const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_ERROR << "Calling virtual function for FinalizeNonLinearIteration"<< std::endl;; -} - -/** - * Computes the material response in terms of stresses and constitutive tensor - * @see Parameters - * @see StressMeasures - */ - -void ConstitutiveLaw::CalculateMaterialResponse(Parameters& rValues,const StressMeasure& rStressMeasure) -{ - switch(rStressMeasure) - { - case StressMeasure_PK1: - CalculateMaterialResponsePK1(rValues); - break; - - case StressMeasure_PK2: - CalculateMaterialResponsePK2(rValues); - break; - - case StressMeasure_Kirchhoff: - CalculateMaterialResponseKirchhoff(rValues); - break; - - case StressMeasure_Cauchy: - CalculateMaterialResponseCauchy(rValues); - break; - - default: - KRATOS_ERROR << " Stress Measure not Defined "<< std::endl;; - break; - - } -} - - -/** - * Computes the material response in terms of 1st Piola-Kirchhoff stresses and constitutive tensor - * @see Parameters - */ - -void ConstitutiveLaw::CalculateMaterialResponsePK1 (Parameters& rValues) -{ - KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponsePK1"<< std::endl;; -} - -/** - * Computes the material response in terms of 2nd Piola-Kirchhoff stresses and constitutive tensor - * @see Parameters - */ - -void ConstitutiveLaw::CalculateMaterialResponsePK2 (Parameters& rValues) -{ - KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponsePK2"<< std::endl;; -} - -/** - * Computes the material response in terms of Kirchhoff stresses and constitutive tensor - * @see Parameters - */ - -void ConstitutiveLaw::CalculateMaterialResponseKirchhoff (Parameters& rValues) -{ - KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponseKirchhoff"<< std::endl;; -} - -/** - * Computes the material response in terms of Cauchy stresses and constitutive tensor - * @see Parameters - */ - -void ConstitutiveLaw::CalculateMaterialResponseCauchy (Parameters& rValues) -{ - KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponseCauchy"<< std::endl;; -} - -/** - * Updates the material response, called by the element in FinalizeSolutionStep. - * @see Parameters - * @see StressMeasures - */ - -void ConstitutiveLaw::FinalizeMaterialResponse(Parameters& rValues,const StressMeasure& rStressMeasure) -{ - switch(rStressMeasure) - { - case StressMeasure_PK1: - FinalizeMaterialResponsePK1(rValues); - break; - - case StressMeasure_PK2: - FinalizeMaterialResponsePK2(rValues); - break; - - case StressMeasure_Kirchhoff: - FinalizeMaterialResponseKirchhoff(rValues); - break; - - case StressMeasure_Cauchy: - FinalizeMaterialResponseCauchy(rValues); - break; - - default: - KRATOS_ERROR << " Stress Measure not Defined "<< std::endl;; - break; - } -} - - -/** - * Updates the material response in terms of 1st Piola-Kirchhoff stresses - * @see Parameters - */ - -void ConstitutiveLaw::FinalizeMaterialResponsePK1 (Parameters& rValues) -{ - KRATOS_ERROR << "Calling virtual function for FinalizeMaterialResponsePK1"<< std::endl;; -} - -/** - * Updates the material response in terms of 2nd Piola-Kirchhoff stresses - * @see Parameters - */ - -void ConstitutiveLaw::FinalizeMaterialResponsePK2 (Parameters& rValues) -{ - KRATOS_ERROR << "Calling virtual function for FinalizeMaterialResponsePK2"<< std::endl;; -} - -/** - * Updates the material response in terms of Kirchhoff stresses - * @see Parameters - */ - -void ConstitutiveLaw::FinalizeMaterialResponseKirchhoff (Parameters& rValues) -{ - KRATOS_ERROR << "Calling virtual function for FinalizeMaterialResponseKirchhoff"<< std::endl;; -} - -/** - * Updates the material response in terms of Cauchy stresses - * @see Parameters - */ - -void ConstitutiveLaw::FinalizeMaterialResponseCauchy (Parameters& rValues) -{ - KRATOS_ERROR << "Calling virtual function for FinalizeMaterialResponseCauchy"<< std::endl;; -} - - - -/** - * This can be used in order to reset all internal variables of the - * constitutive law (e.g. if a model should be reset to its reference state) - * @param rMaterialProperties the Properties instance of the current element - * @param rElementGeometry the geometry of the current element - * @param rShapeFunctionsValues the shape functions values in the current integration point - * @param the current ProcessInfo instance - */ -void ConstitutiveLaw::ResetMaterial(const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, - const Vector& rShapeFunctionsValues) -{ - KRATOS_ERROR << "Calling virtual function for ResetMaterial"<< std::endl;; -} - - - - -/** - * Methods to transform strain Vectors: - * @param rStrainVector the strain tensor in matrix which its stress measure will be changed - * @param rF the DeformationGradientF matrix between the configurations - * @param rdetF the determinant of the DeformationGradientF matrix between the configurations - * @param rStrainInitial the measure of stress of the given rStrainVector - * @param rStrainFinal the measure of stress of the returned rStrainVector - */ -Vector& ConstitutiveLaw::TransformStrains (Vector& rStrainVector, - const Matrix &rF, - StrainMeasure rStrainInitial, - StrainMeasure rStrainFinal) -{ - - switch(rStrainInitial) - { - case StrainMeasure_GreenLagrange: - - switch(rStrainFinal) - { - case StrainMeasure_GreenLagrange: - break; - - case StrainMeasure_Almansi: - { - Matrix StrainMatrix = MathUtils::StrainVectorToTensor( rStrainVector ); - - CoVariantPushForward (StrainMatrix,rF); //Almansi - - rStrainVector = MathUtils::StrainTensorToVector( StrainMatrix, rStrainVector.size() ); - } - break; - - case StrainMeasure_Hencky_Material: - KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; - break; - - case StrainMeasure_Hencky_Spatial: - KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; - break; - - default: - KRATOS_ERROR << "FINAL STRAIN NOT DEFINED in StrainTransformation"<< std::endl;; - break; - } - - break; - - case StrainMeasure_Almansi: - - switch(rStrainFinal) - { - case StrainMeasure_GreenLagrange: - { - Matrix StrainMatrix = MathUtils::StrainVectorToTensor( rStrainVector ); - - CoVariantPullBack (StrainMatrix,rF); //GreenLagrange - - rStrainVector = MathUtils::StrainTensorToVector( StrainMatrix, rStrainVector.size() ); - } - break; - - case StrainMeasure_Almansi: - break; - - case StrainMeasure_Hencky_Material: - KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; - break; - - case StrainMeasure_Hencky_Spatial: - KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; - break; - - default: - KRATOS_ERROR << "FINAL STRAIN NOT DEFINED in StrainTransformation"<< std::endl;; - break; - } - - break; - - case StrainMeasure_Hencky_Material: - KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; - break; - - case StrainMeasure_Hencky_Spatial: - KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; - break; - - default: - KRATOS_ERROR << "Measure of strain NOT DEFINED in Strains Transformation"<< std::endl;; - break; - } - - - return rStrainVector; - -} - - -/** - * Methods to transform stress Matrices: - * @param rStressMatrix the stress tensor in matrix which its stress measure will be changed - * @param rF the DeformationGradientF matrix between the configurations - * @param rdetF the determinant of the DeformationGradientF matrix between the configurations - * @param rStressInitial the measure of stress of the given rStressMatrix - * @param rStressFinal the measure of stress of the returned rStressMatrix - */ -Matrix& ConstitutiveLaw::TransformStresses (Matrix& rStressMatrix, - const Matrix &rF, - const double &rdetF, - StressMeasure rStressInitial, - StressMeasure rStressFinal) -{ - Vector StressVector; - - StressVector = MathUtils::StressTensorToVector( rStressMatrix ); - - StressVector=TransformStresses(StressVector,rF,rdetF,rStressInitial,rStressFinal); - - rStressMatrix = MathUtils::StressVectorToTensor( StressVector ); - - return rStressMatrix; -} - - -/** - * Methods to transform stress Vectors: - * @param rStressVector the stress tensor in matrix which its stress measure will be changed - * @param rF the DeformationGradientF matrix between the configurations - * @param rdetF the determinant of the DeformationGradientF matrix between the configurations - * @param rStressInitial the measure of stress of the given rStressVector - * @param rStressFinal the measure of stress of the returned rStressVector - */ -Vector& ConstitutiveLaw::TransformStresses (Vector& rStressVector, - const Matrix &rF, - const double &rdetF, - StressMeasure rStressInitial, - StressMeasure rStressFinal) -{ - - switch(rStressInitial) - { - case StressMeasure_PK1: - - TransformPK1Stresses(rStressVector,rF,rdetF,rStressFinal); - - break; - - case StressMeasure_PK2: - - TransformPK2Stresses(rStressVector,rF,rdetF,rStressFinal); - - break; - - case StressMeasure_Kirchhoff: - - TransformKirchhoffStresses(rStressVector,rF,rdetF,rStressFinal); - - break; - - case StressMeasure_Cauchy: - - TransformCauchyStresses(rStressVector,rF,rdetF,rStressFinal); - - break; - - default: - KRATOS_ERROR << "INITIAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; - break; - } - - - return rStressVector; - -} - - -/** - * Methods to transform stress Vectors specialized with the initial stress Measure PK1: - * @param rStressVector the stress tensor in matrix which its stress measure will be changed - * @param rF the DeformationGradientF matrix between the configurations - * @param rdetF the determinant of the DeformationGradientF matrix between the configurations - * @param rStressFinal the measure of stress of the returned rStressVector - */ -Vector& ConstitutiveLaw::TransformPK1Stresses (Vector& rStressVector, - const Matrix &rF, - const double &rdetF, - StressMeasure rStressFinal) -{ - unsigned int size = rF.size1(); //WorkingSpaceDimension(); - - switch(rStressFinal) - { - case StressMeasure_PK1: - break; - - case StressMeasure_PK2: - { - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - Matrix InvF ( size, size ); - double J; - MathUtils::InvertMatrix( rF, InvF, J ); - - StressMatrix = prod( InvF, StressMatrix ); //PK2 - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - } - break; - - case StressMeasure_Kirchhoff: - { - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - Matrix InvF ( size, size ); - double J; - MathUtils::InvertMatrix( rF, InvF, J ); - - StressMatrix = prod( InvF, StressMatrix ); //PK2 - - ContraVariantPushForward (StressMatrix,rF); //Kirchhoff - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - } - break; - - case StressMeasure_Cauchy: - { - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - Matrix InvF ( size, size ); - double J; - MathUtils::InvertMatrix( rF, InvF, J ); - - StressMatrix = prod( InvF, StressMatrix ); //PK2 - - ContraVariantPushForward (StressMatrix,rF); //Kirchhoff - - StressMatrix/=J; //Cauchy - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - } - break; - - default: - KRATOS_ERROR << "FINAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; - break; - } - - - return rStressVector; - -} - -/** - * Methods to transform stress Vectors specialized with the initial stress Measure PK2: - * @param rStressVector the stress tensor in matrix which its stress measure will be changed - * @param rF the DeformationGradientF matrix between the configurations - * @param rdetF the determinant of the DeformationGradientF matrix between the configurations - * @param rStressFinal the measure of stress of the returned rStressVector - */ -Vector& ConstitutiveLaw::TransformPK2Stresses (Vector& rStressVector, - const Matrix &rF, - const double &rdetF, - StressMeasure rStressFinal) -{ - - switch(rStressFinal) - { - case StressMeasure_PK1: - { - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - - StressMatrix = prod( rF, StressMatrix ); //PK1 - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - } - break; - - case StressMeasure_PK2: - break; - - case StressMeasure_Kirchhoff: - { - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - - ContraVariantPushForward (StressMatrix,rF); //Kirchhoff - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - } - break; - - case StressMeasure_Cauchy: - { - - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - - ContraVariantPushForward (StressMatrix,rF); //Kirchhoff - - if(rdetF!=0) - StressMatrix/=rdetF; //Cauchy - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - - } - break; - - default: - KRATOS_ERROR << "FINAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; - break; - } - - return rStressVector; - -} - -/** - * Methods to transform stress Vectors specialized with the initial stress Measure Kirchooff: - * @param rStressVector the stress tensor in matrix which its stress measure will be changed - * @param rF the DeformationGradientF matrix between the configurations - * @param rdetF the determinant of the DeformationGradientF matrix between the configurations - * @param rStressFinal the measure of stress of the returned rStressVector - */ -Vector& ConstitutiveLaw::TransformKirchhoffStresses (Vector& rStressVector, - const Matrix &rF, - const double &rdetF, - StressMeasure rStressFinal) -{ - - switch(rStressFinal) - { - case StressMeasure_PK1: - { - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - - ContraVariantPullBack (StressMatrix,rF); //PK2 - - StressMatrix = prod( rF, StressMatrix ); //PK1 - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - } - break; - - case StressMeasure_PK2: - { - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - - ContraVariantPullBack (StressMatrix,rF); //PK2 - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - } - break; - - case StressMeasure_Kirchhoff: - break; - - case StressMeasure_Cauchy: - { - if(rdetF!=0) - rStressVector/=rdetF; //Cauchy - } - break; - - default: - KRATOS_ERROR << "FINAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; - break; - } - - return rStressVector; - -} - -/** - * Methods to transform stress Vectors specialized with the initial stress Measure Cauchy: - * @param rStressVector the stress tensor in matrix which its stress measure will be changed - * @param rF the DeformationGradientF matrix between the configurations - * @param rdetF the determinant of the DeformationGradientF matrix between the configurations - * @param rStressFinal the measure of stress of the returned rStressVector - */ -Vector& ConstitutiveLaw::TransformCauchyStresses (Vector& rStressVector, - const Matrix &rF, - const double &rdetF, - StressMeasure rStressFinal) -{ - - switch(rStressFinal) - { - case StressMeasure_PK1: - { - rStressVector*=rdetF; //Kirchhoff - - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - - ContraVariantPullBack (StressMatrix,rF); //PK2 - - StressMatrix = prod( rF, StressMatrix ); //PK1 - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - } - break; - - case StressMeasure_PK2: - { - rStressVector*=rdetF; //Kirchhoff - - Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); - - ContraVariantPullBack (StressMatrix,rF); //PK2 - - rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); - } - break; - - case StressMeasure_Kirchhoff: - - rStressVector*=rdetF; //Kirchhoff - - break; - - case StressMeasure_Cauchy: - break; - - default: - KRATOS_ERROR << "FINAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; - break; - } - - return rStressVector; - -} - - -/** - * Methods to transform Constitutive Matrices: - * @param rConstitutiveMatrix the constitutive matrix - * @param rF the DeformationGradientF matrix between the configurations - */ - -/** - * This method performs a pull-back of the constitutive matrix - */ -void ConstitutiveLaw::PullBackConstitutiveMatrix ( Matrix& rConstitutiveMatrix, - const Matrix & rF ) -{ - Matrix OriginalConstitutiveMatrix = rConstitutiveMatrix; - - rConstitutiveMatrix.clear(); - - Matrix InverseF ( 3, 3 ); - double detF = 0; - MathUtils::InvertMatrix( rF, InverseF, detF); - - ConstitutiveMatrixTransformation( rConstitutiveMatrix, OriginalConstitutiveMatrix, InverseF ); -} - - -/** - * This method performs a push-forward of the constitutive matrix - */ -void ConstitutiveLaw::PushForwardConstitutiveMatrix ( Matrix& rConstitutiveMatrix, - const Matrix & rF ) -{ - Matrix OriginalConstitutiveMatrix = rConstitutiveMatrix; - - rConstitutiveMatrix.clear(); - - ConstitutiveMatrixTransformation( rConstitutiveMatrix, OriginalConstitutiveMatrix, rF ); -} - - -/** - * This function is designed to be called once to check compatibility with element - * @param rFeatures - */ -void ConstitutiveLaw::GetLawFeatures(Features& rFeatures) -{ - - KRATOS_ERROR << "Calling virtual function for GetConstitutiveLawFeatures"<< std::endl;; -} - -/** - * This function is designed to be called once to perform all the checks needed - * on the input provided. Checks can be "expensive" as the function is designed - * to catch user's errors. - * @param rMaterialProperties - * @param rElementGeometry - * @param rCurrentProcessInfo - * @return - */ -int ConstitutiveLaw::Check(const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, - const ProcessInfo& rCurrentProcessInfo) -{ - KRATOS_TRY - - return 0; - KRATOS_CATCH(""); -} - - -//*** PROTECTED METHODS: ***// - -/** - * This method performs a contra-variant push-forward between to tensors - * i.e. 2nd PK stress to Kirchhoff stress - */ - -void ConstitutiveLaw::ContraVariantPushForward( Matrix& rMatrix, - const Matrix& rF) //i.e. 2nd PK stress to Kirchhoff stress -{ - unsigned int size = rF.size1(); //WorkingSpaceDimension(); - Matrix temp ( size, size ); - - noalias( temp ) = prod( rF, rMatrix ); - noalias( rMatrix ) = prod( temp, trans( rF ) ); - -} - -/** - * This method performs a contra-variant pull-back between to tensors - * i.e. Kirchhoff stress to 2nd PK stress - */ - -void ConstitutiveLaw::ContraVariantPullBack( Matrix& rMatrix, - const Matrix& rF) //i.e. Kirchhoff stress to 2nd PK stress -{ - unsigned int size = rF.size1(); //WorkingSpaceDimension(); - Matrix InvF ( size, size ); - double J; - MathUtils::InvertMatrix( rF, InvF, J ); - - Matrix temp ( size, size ); - - noalias( temp ) = prod( InvF, rMatrix ); - noalias( rMatrix ) = prod( temp, trans( InvF ) ); -} - -/** - * This method performs a co-variant push-forward between to tensors - * i.e. Green-Lagrange strain to Almansi strain - */ - -void ConstitutiveLaw::CoVariantPushForward( Matrix& rMatrix, - const Matrix& rF) //i.e. Green-Lagrange strain to Almansi strain -{ - unsigned int size = rF.size1(); //WorkingSpaceDimension(); - Matrix InvF ( size, size ); - double J; - MathUtils::InvertMatrix( rF, InvF, J ); - - Matrix temp ( size, size ); - - noalias( temp ) = prod( trans( InvF ), rMatrix ); - noalias( rMatrix ) = prod( temp, InvF ); -} - -/** - * This method performs a co-variant pull-back between to tensors - * i.e. Almansi strain to Green-Lagrange strain - */ - -void ConstitutiveLaw::CoVariantPullBack( Matrix& rMatrix, - const Matrix& rF) //i.e. Almansi strain to Green-Lagrange strain -{ - - unsigned int size = rF.size1(); //WorkingSpaceDimension(); - Matrix temp ( size, size ); - - noalias( temp ) = prod( trans( rF ), rMatrix ); - noalias( rMatrix ) = prod( temp, rF ); - -} - - -/** - * This method performs a pull-back or a push-forward between two constitutive matrices - */ -void ConstitutiveLaw::ConstitutiveMatrixTransformation ( Matrix& rConstitutiveMatrix, - const Matrix& rOriginalConstitutiveMatrix, - const Matrix & rF ) -{ - unsigned int size = rOriginalConstitutiveMatrix.size1(); - if( size == 6 ) - { - - for(unsigned int i=0; i<6; i++) - { - for(unsigned int j=0; j<6; j++) - { - rConstitutiveMatrix( i, j ) = TransformConstitutiveComponent(rConstitutiveMatrix( i, j ), rOriginalConstitutiveMatrix, rF, - this->msIndexVoigt3D6C[i][0], this->msIndexVoigt3D6C[i][1], this->msIndexVoigt3D6C[j][0], this->msIndexVoigt3D6C[j][1]); - } - - } - } - else if( size == 4 ) - { - - - for(unsigned int i=0; i<4; i++) - { - for(unsigned int j=0; j<4; j++) - { - rConstitutiveMatrix( i, j ) = TransformConstitutiveComponent(rConstitutiveMatrix( i, j ), rOriginalConstitutiveMatrix, rF, - this->msIndexVoigt2D4C[i][0], this->msIndexVoigt2D4C[i][1], this->msIndexVoigt2D4C[j][0], this->msIndexVoigt2D4C[j][1]); - } - - } - } - else if( size == 3 ) - { - - - for(unsigned int i=0; i<3; i++) - { - for(unsigned int j=0; j<3; j++) - { - rConstitutiveMatrix( i, j ) = TransformConstitutiveComponent(rConstitutiveMatrix( i, j ), rOriginalConstitutiveMatrix, rF, - this->msIndexVoigt2D3C[i][0], this->msIndexVoigt2D3C[i][1], this->msIndexVoigt2D3C[j][0], this->msIndexVoigt2D3C[j][1]); - } - - } - } - - -} - - - -/** - * This method performs a pull-back or a push-forward between two constitutive tensor components - */ -double& ConstitutiveLaw::TransformConstitutiveComponent(double & rCabcd, - const Matrix & rConstitutiveMatrix, - const Matrix & rF, - const unsigned int& a, const unsigned int& b, - const unsigned int& c, const unsigned int& d) - -{ - - rCabcd = 0; - double Cijkl=0; - - unsigned int dimension = rF.size1(); - - //Cabcd - for(unsigned int j=0; jmsIndexVoigt2D3C[i][0] == a && this->msIndexVoigt2D3C[i][1] == b ) - { - k = i; - break; - } - } - else - { - if( (this->msIndexVoigt2D3C[i][0] == a && this->msIndexVoigt2D3C[i][1] == b) || - (this->msIndexVoigt2D3C[i][1] == a && this->msIndexVoigt2D3C[i][0] == b) ) - { - k = i; - break; - } - } - } - - //index l - for(unsigned int i=0; i<3; i++) - { - if( c == d ) - { - if( this->msIndexVoigt2D3C[i][0] == c && this->msIndexVoigt2D3C[i][1] == d ) - { - l = i; - break; - } - } - else - { - if( (this->msIndexVoigt2D3C[i][0] == c && this->msIndexVoigt2D3C[i][1] == d) || - (this->msIndexVoigt2D3C[i][1] == c && this->msIndexVoigt2D3C[i][0] == d) ) - { - l = i; - break; - } - } - } - - - } - else if( size == 4 ) - { - - //index k - for(unsigned int i=0; i<4; i++) - { - if( a == b ) - { - if( this->msIndexVoigt2D4C[i][0] == a && this->msIndexVoigt2D4C[i][1] == b ) - { - k = i; - break; - } - } - else - { - if( (this->msIndexVoigt2D4C[i][0] == a && this->msIndexVoigt2D4C[i][1] == b) || - (this->msIndexVoigt2D4C[i][1] == a && this->msIndexVoigt2D4C[i][0] == b) ) - { - k = i; - break; - } - } - } - - //index l - for(unsigned int i=0; i<4; i++) - { - if( c == d ) - { - if( this->msIndexVoigt2D4C[i][0] == c && this->msIndexVoigt2D4C[i][1] == d ) - { - l = i; - break; - } - } - else - { - if( (this->msIndexVoigt2D4C[i][0] == c && this->msIndexVoigt2D4C[i][1] == d) || - (this->msIndexVoigt2D4C[i][1] == c && this->msIndexVoigt2D4C[i][0] == d) ) - { - l = i; - break; - } - } - } - - } - else if( size == 6 ) - { - - //index k - for(unsigned int i=0; i<6; i++) - { - if( a == b ) - { - if( this->msIndexVoigt3D6C[i][0] == a && this->msIndexVoigt3D6C[i][1] == b ) - { - k = i; - break; - } - } - else - { - if( (this->msIndexVoigt3D6C[i][0] == a && this->msIndexVoigt3D6C[i][1] == b) || - (this->msIndexVoigt3D6C[i][1] == a && this->msIndexVoigt3D6C[i][0] == b) ) - { - k = i; - break; - } - } - } - - //index l - for(unsigned int i=0; i<6; i++) - { - if( c == d ) - { - if( this->msIndexVoigt3D6C[i][0] == c && this->msIndexVoigt3D6C[i][1] == d ) - { - l = i; - break; - } - } - else - { - if( (this->msIndexVoigt3D6C[i][0] == c && this->msIndexVoigt3D6C[i][1] == d) || - (this->msIndexVoigt3D6C[i][1] == c && this->msIndexVoigt3D6C[i][0] == d) ) - { - l = i; - break; - } - } - } - } - - rCabcd = rConstitutiveMatrix(k,l); - - return rCabcd; -} - -//*** OUTDATED METHODS: ***// - - - -/** - * Computes the material response in terms of stresses and algorithmic tangent - * @param StrainVector the current strains (total strains, input) - * @param DeformationGradient the current deformation gradient (can be an empty matrix if a linear strain measure is used) - * @param StressVector the computed stresses (output) - * @param algorithmicTangent the material tangent matrix (output) - * @param rCurrentProcessInfo current ProcessInfo instance - * @param rMaterialProperties the material's Properties object - * @param rElementGeometry the element's geometry - * @param rShapeFunctionsValues the shape functions values in the current integration pointer - * @param CalculateStresses flag whether or not to compute the stress response - * @param CalculateTangent flag to determine if to compute the material tangent - * NOTE: the CalculateTangent flag is defined as int to allow for distinctive variants of the tangent - * @param SaveInternalVariables flag whether or not to store internal (history) variables - */ -void ConstitutiveLaw::CalculateMaterialResponse(const Vector& StrainVector, - const Matrix& DeformationGradient, - Vector& StressVector, - Matrix& AlgorithmicTangent, - const ProcessInfo& rCurrentProcessInfo, - const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, - const Vector& rShapeFunctionsValues, - bool CalculateStresses, - int CalculateTangent, - bool SaveInternalVariables) -{ - KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponse"<< std::endl;; -} - -/** - * Computes the volumetric part of the material response in terms of stresses and algorithmic tangent - * @param StrainVector the current strains (total strains, input) - * @param DeformationGradient the current deformation gradient (can be an empty matrix if a linear - * @param StressVector the computed stresses (output) - * @param algorithmicTangent the material tangent matrix (output) - * @param rCurrentProcessInfo current ProcessInfo instance - * @param rMaterialProperties the material's Properties object - * @param rElementGeometry the element's geometry - * @param rShapeFunctionsValues the shape functions values in the current integration pointer - * @param CalculateStresses flag whether or not to compute the stress response - * @param CalculateTangent flag to determine if to compute the material tangent - * NOTE: the CalculateTangent flag is defined as int to allow for distinctive variants of the tangent - * @param SaveInternalVariables flag whether or not to store internal (history) variables - */ -void ConstitutiveLaw::CalculateVolumetricResponse(const double VolumetricStrain, - const Matrix& DeformationGradient, - double& VolumetricStress, - double& AlgorithmicBulk, - const ProcessInfo& rCurrentProcessInfo, - const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, - const Vector& rShapeFunctionsValues, - bool CalculateStresses, - int CalculateTangent, - bool SaveInternalVariables) -{ - KRATOS_ERROR << "Calling virtual function for CalculateVolumetricResponse"<< std::endl;; -} - -/** - * Computes the deviatoric part of the material response in terms of stresses and algorithmic tangent - * @param StrainVector the current strains (total strains, input) - * @param DeformationGradient the current deformation gradient (can be an empty matrix if a linear - * @param StressVector the computed stresses (output) - * @param algorithmicTangent the material tangent matrix (output) - * @param rCurrentProcessInfo current ProcessInfo instance - * @param rMaterialProperties the material's Properties object - * TODO: add proper definition for algorithmic tangent - */ -void ConstitutiveLaw::CalculateDeviatoricResponse(const Vector& StrainVector, - const Matrix& DeformationGradient, - Vector& StressVector, - Matrix& AlgorithmicTangent, - const ProcessInfo& rCurrentProcessInfo, - const Properties& rMaterialProperties, - const GeometryType& rElementGeometry, - const Vector& rShapeFunctionsValues, - bool CalculateStresses, - int CalculateTangent, - bool SaveInternalVariables) -{ - KRATOS_ERROR << "Calling virtual function for CalculateDeviatoricResponse"<< std::endl;; -} - - -// VM -void ConstitutiveLaw::CalculateCauchyStresses(Vector& Cauchy_StressVector, - const Matrix& F, - const Vector& PK2_StressVector, - const Vector& GreenLagrangeStrainVector) -{ -} - - - - -} /* namespace Kratos.*/ - +// | / | +// ' / __| _` | __| _ \ __| +// . \ | ( | | ( |\__ \. +// _|\_\_| \__,_|\__|\___/ ____/ +// Multi-Physics +// +// License: BSD License +// Kratos default license: kratos/license.txt +// +// Main authors: Riccardo Rossi +// Janosch Stascheit +// Nelson Maireni Lafontaine +// Josep Maria Carbonell +// + +#include "includes/constitutive_law.h" + + +namespace Kratos +{ + const unsigned int ConstitutiveLaw::msIndexVoigt3D6C [6][2] = { {0, 0}, {1, 1}, {2, 2}, {0, 1}, {1, 2}, {0, 2} }; + const unsigned int ConstitutiveLaw::msIndexVoigt2D4C [4][2] = { {0, 0}, {1, 1}, {2, 2}, {0, 1} }; + const unsigned int ConstitutiveLaw::msIndexVoigt2D3C [3][2] = { {0, 0}, {1, 1}, {0, 1} }; + + + /** + * Flags related to the Parameters of the Contitutive Law + */ + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, USE_ELEMENT_PROVIDED_STRAIN, 0 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, COMPUTE_STRESS, 1 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, COMPUTE_CONSTITUTIVE_TENSOR, 2 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, COMPUTE_STRAIN_ENERGY, 3 ); + + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, ISOCHORIC_TENSOR_ONLY, 4 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, VOLUMETRIC_TENSOR_ONLY, 5 ); + + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, MECHANICAL_RESPONSE_ONLY, 6 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, THERMAL_RESPONSE_ONLY, 7 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, INCREMENTAL_STRAIN_MEASURE, 8 ); + + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, INITIALIZE_MATERIAL_RESPONSE, 9 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, FINALIZE_MATERIAL_RESPONSE, 10 ); + + + /** + * Flags related to the Features of the Contitutive Law + */ + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, FINITE_STRAINS, 1 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, INFINITESIMAL_STRAINS, 2 ); + + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, THREE_DIMENSIONAL_LAW, 3 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, PLANE_STRAIN_LAW, 4 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, PLANE_STRESS_LAW, 5 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, AXISYMMETRIC_LAW, 6 ); + + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, U_P_LAW, 7 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, ISOTROPIC, 8 ); + KRATOS_CREATE_LOCAL_FLAG( ConstitutiveLaw, ANISOTROPIC, 9 ); + +/** + * Constructor. + */ +ConstitutiveLaw::ConstitutiveLaw() : Flags() +{ +} + + +/** + * Clone function (has to be implemented by any derived class) + * @return a pointer to a new instance of this constitutive law + * NOTE: implementation scheme: + * ConstitutiveLaw::Pointer p_clone(new ConstitutiveLaw()); + * return p_clone; + */ +ConstitutiveLaw::Pointer ConstitutiveLaw::Clone() const +{ + KRATOS_ERROR << "Called the virtual function for Clone"<< std::endl;; +} + +/** + * @return the working space dimension of the current constitutive law + * NOTE: this function HAS TO BE IMPLEMENTED by any derived class + */ +ConstitutiveLaw::SizeType ConstitutiveLaw::WorkingSpaceDimension() +{ + KRATOS_ERROR << "Called the virtual function for WorkingSpaceDimension"<< std::endl;; +} + +/** + * returns the size of the strain vector of the current constitutive law + * NOTE: this function HAS TO BE IMPLEMENTED by any derived class + */ +ConstitutiveLaw::SizeType ConstitutiveLaw::GetStrainSize() +{ + KRATOS_ERROR << "Called the virtual function for GetStrainSize"<< std::endl;; +} + +/** + * returns whether this constitutive Law has specified variable + * @param rThisVariable the variable to be checked for + * @return true if the variable is defined in the constitutive law + */ +bool ConstitutiveLaw::Has(const Variable& rThisVariable) +{ + return false; +} + +/** + * returns whether this constitutive Law has specified variable + * @param rThisVariable the variable to be checked for + * @return true if the variable is defined in the constitutive law + */ +bool ConstitutiveLaw::Has(const Variable& rThisVariable) +{ + return false; +} + +/** + * returns whether this constitutive Law has specified variable + * @param rThisVariable the variable to be checked for + * @return true if the variable is defined in the constitutive law + */ +bool ConstitutiveLaw::Has(const Variable& rThisVariable) +{ + return false; +} + +/** + * returns whether this constitutive Law has specified variable + * @param rThisVariable the variable to be checked for + * @return true if the variable is defined in the constitutive law + */ +bool ConstitutiveLaw::Has(const Variable& rThisVariable) +{ + return false; +} + +/** + * returns whether this constitutive Law has specified variable + * @param rThisVariable the variable to be checked for + * @return true if the variable is defined in the constitutive law + * NOTE: fixed size array of 3 doubles (e.g. for 2D stresses, plastic strains, ...) + */ +bool ConstitutiveLaw::Has(const Variable >& rThisVariable) +{ + return false; +} + +/** + * returns whether this constitutive Law has specified variable + * @param rThisVariable the variable to be checked for + * @return true if the variable is defined in the constitutive law + * NOTE: fixed size array of 6 doubles (e.g. for stresses, plastic strains, ...) + */ +bool ConstitutiveLaw::Has(const Variable >& rThisVariable) +{ + return false; +} + +/** + * returns the value of a specified variable + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ +int& ConstitutiveLaw::GetValue(const Variable& rThisVariable, int& rValue) +{ + return rValue; +} + +/** + * returns the value of a specified variable + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ +double& ConstitutiveLaw::GetValue(const Variable& rThisVariable, double& rValue) +{ + return rValue; +} + +/** + * returns the value of a specified variable + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @return the value of the specified variable + */ +Vector& ConstitutiveLaw::GetValue(const Variable& rThisVariable, Vector& rValue) +{ + return rValue; +} + +/** + * returns the value of a specified variable + * @param rThisVariable the variable to be returned + * @return the value of the specified variable + */ +Matrix& ConstitutiveLaw::GetValue(const Variable& rThisVariable, Matrix& rValue) +{ + return rValue; +} + +/** + * returns the value of a specified variable + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @return the value of the specified variable + */ +array_1d & ConstitutiveLaw::GetValue(const Variable >& rVariable, + array_1d & rValue) +{ + return rValue; +} + +/** + * returns the value of a specified variable + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @return the value of the specified variable + */ +array_1d & ConstitutiveLaw::GetValue(const Variable >& rVariable, + array_1d & rValue) +{ + return rValue; +} + +/** + * sets the value of a specified variable + * @param rVariable the variable to be returned + * @param Value new value of the specified variable + * @param rCurrentProcessInfo the process info + */ +void ConstitutiveLaw::SetValue(const Variable& rVariable, + const int& Value, + const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; +} + +/** + * sets the value of a specified variable + * @param rVariable the variable to be returned + * @param rValue new value of the specified variable + * @param rCurrentProcessInfo the process info + */ +void ConstitutiveLaw::SetValue(const Variable& rVariable, + const double& rValue, + const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; +} + +/** + * sets the value of a specified variable + * @param rVariable the variable to be returned + * @param rValue new value of the specified variable + * @param rCurrentProcessInfo the process info + */ +void ConstitutiveLaw::SetValue(const Variable& rVariable, + const Vector& rValue, const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; +} + +/** + * sets the value of a specified variable + * @param rVariable the variable to be returned + * @param rValue new value of the specified variable + * @param rCurrentProcessInfo the process info + */ +void ConstitutiveLaw::SetValue(const Variable& rVariable, + const Matrix& rValue, const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; +} + +/** + * sets the value of a specified variable + * @param rVariable the variable to be returned + * @param rValue new value of the specified variable + * @param rCurrentProcessInfo the process info + */ +void ConstitutiveLaw::SetValue(const Variable >& rVariable, + const array_1d & rValue, + const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; +} + +/** + * sets the value of a specified variable + * @param rVariable the variable to be returned + * @param rValue new value of the specified variable + * @param rCurrentProcessInfo the process info + */ +void ConstitutiveLaw::SetValue(const Variable >& rVariable, + const array_1d & rValue, + const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_ERROR << "Called the virtual function for SetValue"<< std::endl;; +} + + + +/** + * calculates the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ +int& ConstitutiveLaw::CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, int& rValue) +{ + return rValue; +} + +/** + * returns the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ +double& ConstitutiveLaw::CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, double& rValue) +{ + return rValue; +} + +/** + * returns the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ +Vector& ConstitutiveLaw::CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, Vector& rValue) +{ + return rValue; +} + +/** + * returns the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ +Matrix& ConstitutiveLaw::CalculateValue(Parameters& rParameterValues, const Variable& rThisVariable, Matrix& rValue) +{ + return rValue; +} + +/** + * returns the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ +array_1d & ConstitutiveLaw::CalculateValue(Parameters& rParameterValues, const Variable >& rVariable, + array_1d & rValue) +{ + return rValue; +} + + + /** + * returns the value of a specified variable + * @param rParameterValues the needed parameters for the CL calculation + * @param rThisVariable the variable to be returned + * @param rValue a reference to the returned value + * @param rValue output: the value of the specified variable + */ +array_1d & ConstitutiveLaw::CalculateValue(Parameters& rParameterValues, const Variable >& rVariable, + array_1d & rValue) +{ + return rValue; +} + +/** + * returns the expected strain measure of this constitutive law (by default linear strains) + * @return the expected strain measure + */ +ConstitutiveLaw::StrainMeasure ConstitutiveLaw::GetStrainMeasure() +{ + return StrainMeasure_Infinitesimal; +} + +/** + * returns the stress measure of this constitutive law (by default 1st Piola-Kirchhoff stress in voigt notation) + * @return the expected stress measure + */ +ConstitutiveLaw::StressMeasure ConstitutiveLaw::GetStressMeasure() +{ + return StressMeasure_PK1; +} + +/** + * returns whether this constitutive model is formulated in incremental strains/stresses + * NOTE: by default, all constitutive models should be formulated in total strains + * @return true, if formulated in incremental strains/stresses, false otherwise + */ +bool ConstitutiveLaw::IsIncremental() +{ + return false; +} + +/** + * This is to be called at the very beginning of the calculation + * (e.g. from InitializeElement) in order to initialize all relevant + * attributes of the constitutive law + * @param rMaterialProperties the Properties instance of the current element + * @param rElementGeometry the geometry of the current element + * @param rShapeFunctionsValues the shape functions values in the current integration point + */ +void ConstitutiveLaw::InitializeMaterial(const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, + const Vector& rShapeFunctionsValues) +{ +} + +/** + * to be called at the beginning of each solution step + * (e.g. from Element::InitializeSolutionStep) + * @param rMaterialProperties the Properties instance of the current element + * @param rElementGeometry the geometry of the current element + * @param rShapeFunctionsValues the shape functions values in the current integration point + * @param the current ProcessInfo instance + */ +void ConstitutiveLaw::InitializeSolutionStep(const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, //this is just to give the array of nodes + const Vector& rShapeFunctionsValues, + const ProcessInfo& rCurrentProcessInfo) +{ +} + +/** + * to be called at the end of each solution step + * (e.g. from Element::FinalizeSolutionStep) + * @param rMaterialProperties the Properties instance of the current element + * @param rElementGeometry the geometry of the current element + * @param rShapeFunctionsValues the shape functions values in the current integration point + * @param the current ProcessInfo instance + */ +void ConstitutiveLaw::FinalizeSolutionStep(const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, + const Vector& rShapeFunctionsValues, + const ProcessInfo& rCurrentProcessInfo) +{ +} + +/** + * to be called at the beginning of each step iteration + * (e.g. from Element::InitializeNonLinearIteration) + * @param rMaterialProperties the Properties instance of the current element + * @param rElementGeometry the geometry of the current element + * @param rShapeFunctionsValues the shape functions values in the current integration point + * @param the current ProcessInfo instance + */ +void ConstitutiveLaw::InitializeNonLinearIteration(const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, + const Vector& rShapeFunctionsValues, + const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_ERROR << "Calling virtual function for InitializeNonLinearIteration"<< std::endl;; +} + + + +/** + * to be called at the end of each step iteration + * (e.g. from Element::FinalizeNonLinearIteration) + * @param rMaterialProperties the Properties instance of the current element + * @param rElementGeometry the geometry of the current element + * @param rShapeFunctionsValues the shape functions values in the current integration point + * @param the current ProcessInfo instance + */ +void ConstitutiveLaw::FinalizeNonLinearIteration(const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, + const Vector& rShapeFunctionsValues, + const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_ERROR << "Calling virtual function for FinalizeNonLinearIteration"<< std::endl;; +} + +/** + * Computes the material response in terms of stresses and constitutive tensor + * @see Parameters + * @see StressMeasures + */ + +void ConstitutiveLaw::CalculateMaterialResponse(Parameters& rValues,const StressMeasure& rStressMeasure) +{ + switch(rStressMeasure) + { + case StressMeasure_PK1: + CalculateMaterialResponsePK1(rValues); + break; + + case StressMeasure_PK2: + CalculateMaterialResponsePK2(rValues); + break; + + case StressMeasure_Kirchhoff: + CalculateMaterialResponseKirchhoff(rValues); + break; + + case StressMeasure_Cauchy: + CalculateMaterialResponseCauchy(rValues); + break; + + default: + KRATOS_ERROR << " Stress Measure not Defined "<< std::endl;; + break; + + } +} + + +/** + * Computes the material response in terms of 1st Piola-Kirchhoff stresses and constitutive tensor + * @see Parameters + */ + +void ConstitutiveLaw::CalculateMaterialResponsePK1 (Parameters& rValues) +{ + KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponsePK1"<< std::endl;; +} + +/** + * Computes the material response in terms of 2nd Piola-Kirchhoff stresses and constitutive tensor + * @see Parameters + */ + +void ConstitutiveLaw::CalculateMaterialResponsePK2 (Parameters& rValues) +{ + KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponsePK2"<< std::endl;; +} + +/** + * Computes the material response in terms of Kirchhoff stresses and constitutive tensor + * @see Parameters + */ + +void ConstitutiveLaw::CalculateMaterialResponseKirchhoff (Parameters& rValues) +{ + KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponseKirchhoff"<< std::endl;; +} + +/** + * Computes the material response in terms of Cauchy stresses and constitutive tensor + * @see Parameters + */ + +void ConstitutiveLaw::CalculateMaterialResponseCauchy (Parameters& rValues) +{ + KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponseCauchy"<< std::endl;; +} + + + /** + * Initialize the material response, called by the element in InitializeSolutionStep. + * @see Parameters + * @see StressMeasures + */ + + void ConstitutiveLaw::InitializeMaterialResponse(Parameters& rValues,const StressMeasure& rStressMeasure) + { + switch(rStressMeasure) + { + case StressMeasure_PK1: InitializeMaterialResponsePK1(rValues); + break; + + case StressMeasure_PK2: InitializeMaterialResponsePK2(rValues); + break; + + case StressMeasure_Kirchhoff: InitializeMaterialResponseKirchhoff(rValues); + break; + + case StressMeasure_Cauchy: InitializeMaterialResponseCauchy(rValues); + break; + + default: + KRATOS_THROW_ERROR(std::logic_error, " Stress Measure not Defined ", ""); + break; + + } + } + + + /** + * Initialize the material response in terms of 1st Piola-Kirchhoff stresses + * @see Parameters + */ + + void ConstitutiveLaw::InitializeMaterialResponsePK1 (Parameters& rValues) + { + KRATOS_THROW_ERROR(std::logic_error, "Calling virtual function for InitializeMaterialResponsePK1", ""); + } + + /** + * Initialize the material response in terms of 2nd Piola-Kirchhoff stresses + * @see Parameters + */ + + void ConstitutiveLaw::InitializeMaterialResponsePK2 (Parameters& rValues) + { + KRATOS_THROW_ERROR(std::logic_error, "Calling virtual function for InitializeMaterialResponsePK2", ""); + } + + /** + * Initialize the material response in terms of Kirchhoff stresses + * @see Parameters + */ + + void ConstitutiveLaw::InitializeMaterialResponseKirchhoff (Parameters& rValues) + { + KRATOS_THROW_ERROR(std::logic_error, "Calling virtual function for InitializeMaterialResponseKirchhoff", ""); + } + + /** + * Initialize the material response in terms of Cauchy stresses + * @see Parameters + */ + + void ConstitutiveLaw::InitializeMaterialResponseCauchy (Parameters& rValues) + { + KRATOS_THROW_ERROR(std::logic_error, "Calling virtual function for InitializeMaterialResponseCauchy", ""); + } + + +/** + * Updates the material response, called by the element in FinalizeSolutionStep. + * @see Parameters + * @see StressMeasures + */ + +void ConstitutiveLaw::FinalizeMaterialResponse(Parameters& rValues,const StressMeasure& rStressMeasure) +{ + switch(rStressMeasure) + { + case StressMeasure_PK1: + FinalizeMaterialResponsePK1(rValues); + break; + + case StressMeasure_PK2: + FinalizeMaterialResponsePK2(rValues); + break; + + case StressMeasure_Kirchhoff: + FinalizeMaterialResponseKirchhoff(rValues); + break; + + case StressMeasure_Cauchy: + FinalizeMaterialResponseCauchy(rValues); + break; + + default: + KRATOS_ERROR << " Stress Measure not Defined "<< std::endl;; + break; + } +} + + +void ConstitutiveLaw::FinalizeMaterialResponsePK1 (Parameters& rValues) +{ + KRATOS_ERROR << "Calling virtual function for FinalizeMaterialResponsePK1"<< std::endl;; +} + +/** + * Updates the material response in terms of 2nd Piola-Kirchhoff stresses + * @see Parameters + */ + +void ConstitutiveLaw::FinalizeMaterialResponsePK2 (Parameters& rValues) +{ + KRATOS_ERROR << "Calling virtual function for FinalizeMaterialResponsePK2"<< std::endl;; +} + +/** + * Updates the material response in terms of Kirchhoff stresses + * @see Parameters + */ + +void ConstitutiveLaw::FinalizeMaterialResponseKirchhoff (Parameters& rValues) +{ + KRATOS_ERROR << "Calling virtual function for FinalizeMaterialResponseKirchhoff"<< std::endl;; +} + +/** + * Updates the material response in terms of Cauchy stresses + * @see Parameters + */ + +void ConstitutiveLaw::FinalizeMaterialResponseCauchy (Parameters& rValues) +{ + KRATOS_ERROR << "Calling virtual function for FinalizeMaterialResponseCauchy"<< std::endl;; +} + + + +/** + * This can be used in order to reset all internal variables of the + * constitutive law (e.g. if a model should be reset to its reference state) + * @param rMaterialProperties the Properties instance of the current element + * @param rElementGeometry the geometry of the current element + * @param rShapeFunctionsValues the shape functions values in the current integration point + * @param the current ProcessInfo instance + */ +void ConstitutiveLaw::ResetMaterial(const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, + const Vector& rShapeFunctionsValues) +{ + KRATOS_ERROR << "Calling virtual function for ResetMaterial"<< std::endl;; +} + + + + +/** + * Methods to transform strain Vectors: + * @param rStrainVector the strain tensor in matrix which its stress measure will be changed + * @param rF the DeformationGradientF matrix between the configurations + * @param rdetF the determinant of the DeformationGradientF matrix between the configurations + * @param rStrainInitial the measure of stress of the given rStrainVector + * @param rStrainFinal the measure of stress of the returned rStrainVector + */ +Vector& ConstitutiveLaw::TransformStrains (Vector& rStrainVector, + const Matrix &rF, + StrainMeasure rStrainInitial, + StrainMeasure rStrainFinal) +{ + + switch(rStrainInitial) + { + case StrainMeasure_GreenLagrange: + + switch(rStrainFinal) + { + case StrainMeasure_GreenLagrange: + break; + + case StrainMeasure_Almansi: + { + Matrix StrainMatrix = MathUtils::StrainVectorToTensor( rStrainVector ); + + CoVariantPushForward (StrainMatrix,rF); //Almansi + + rStrainVector = MathUtils::StrainTensorToVector( StrainMatrix, rStrainVector.size() ); + } + break; + + case StrainMeasure_Hencky_Material: + KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; + break; + + case StrainMeasure_Hencky_Spatial: + KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; + break; + + default: + KRATOS_ERROR << "FINAL STRAIN NOT DEFINED in StrainTransformation"<< std::endl;; + break; + } + + break; + + case StrainMeasure_Almansi: + + switch(rStrainFinal) + { + case StrainMeasure_GreenLagrange: + { + Matrix StrainMatrix = MathUtils::StrainVectorToTensor( rStrainVector ); + + CoVariantPullBack (StrainMatrix,rF); //GreenLagrange + + rStrainVector = MathUtils::StrainTensorToVector( StrainMatrix, rStrainVector.size() ); + } + break; + + case StrainMeasure_Almansi: + break; + + case StrainMeasure_Hencky_Material: + KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; + break; + + case StrainMeasure_Hencky_Spatial: + KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; + break; + + default: + KRATOS_ERROR << "FINAL STRAIN NOT DEFINED in StrainTransformation"<< std::endl;; + break; + } + + break; + + case StrainMeasure_Hencky_Material: + KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; + break; + + case StrainMeasure_Hencky_Spatial: + KRATOS_ERROR << "Hencky strain has no transformation coded"<< std::endl;; + break; + + default: + KRATOS_ERROR << "Measure of strain NOT DEFINED in Strains Transformation"<< std::endl;; + break; + } + + + return rStrainVector; + +} + + +/** + * Methods to transform stress Matrices: + * @param rStressMatrix the stress tensor in matrix which its stress measure will be changed + * @param rF the DeformationGradientF matrix between the configurations + * @param rdetF the determinant of the DeformationGradientF matrix between the configurations + * @param rStressInitial the measure of stress of the given rStressMatrix + * @param rStressFinal the measure of stress of the returned rStressMatrix + */ +Matrix& ConstitutiveLaw::TransformStresses (Matrix& rStressMatrix, + const Matrix &rF, + const double &rdetF, + StressMeasure rStressInitial, + StressMeasure rStressFinal) +{ + Vector StressVector; + + StressVector = MathUtils::StressTensorToVector( rStressMatrix ); + + StressVector=TransformStresses(StressVector,rF,rdetF,rStressInitial,rStressFinal); + + rStressMatrix = MathUtils::StressVectorToTensor( StressVector ); + + return rStressMatrix; +} + + +/** + * Methods to transform stress Vectors: + * @param rStressVector the stress tensor in matrix which its stress measure will be changed + * @param rF the DeformationGradientF matrix between the configurations + * @param rdetF the determinant of the DeformationGradientF matrix between the configurations + * @param rStressInitial the measure of stress of the given rStressVector + * @param rStressFinal the measure of stress of the returned rStressVector + */ +Vector& ConstitutiveLaw::TransformStresses (Vector& rStressVector, + const Matrix &rF, + const double &rdetF, + StressMeasure rStressInitial, + StressMeasure rStressFinal) +{ + + switch(rStressInitial) + { + case StressMeasure_PK1: + + TransformPK1Stresses(rStressVector,rF,rdetF,rStressFinal); + + break; + + case StressMeasure_PK2: + + TransformPK2Stresses(rStressVector,rF,rdetF,rStressFinal); + + break; + + case StressMeasure_Kirchhoff: + + TransformKirchhoffStresses(rStressVector,rF,rdetF,rStressFinal); + + break; + + case StressMeasure_Cauchy: + + TransformCauchyStresses(rStressVector,rF,rdetF,rStressFinal); + + break; + + default: + KRATOS_ERROR << "INITIAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; + break; + } + + + return rStressVector; + +} + + +/** + * Methods to transform stress Vectors specialized with the initial stress Measure PK1: + * @param rStressVector the stress tensor in matrix which its stress measure will be changed + * @param rF the DeformationGradientF matrix between the configurations + * @param rdetF the determinant of the DeformationGradientF matrix between the configurations + * @param rStressFinal the measure of stress of the returned rStressVector + */ +Vector& ConstitutiveLaw::TransformPK1Stresses (Vector& rStressVector, + const Matrix &rF, + const double &rdetF, + StressMeasure rStressFinal) +{ + unsigned int size = rF.size1(); //WorkingSpaceDimension(); + + switch(rStressFinal) + { + case StressMeasure_PK1: + break; + + case StressMeasure_PK2: + { + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + Matrix InvF ( size, size ); + double J; + MathUtils::InvertMatrix( rF, InvF, J ); + + StressMatrix = prod( InvF, StressMatrix ); //PK2 + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + } + break; + + case StressMeasure_Kirchhoff: + { + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + Matrix InvF ( size, size ); + double J; + MathUtils::InvertMatrix( rF, InvF, J ); + + StressMatrix = prod( InvF, StressMatrix ); //PK2 + + ContraVariantPushForward (StressMatrix,rF); //Kirchhoff + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + } + break; + + case StressMeasure_Cauchy: + { + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + Matrix InvF ( size, size ); + double J; + MathUtils::InvertMatrix( rF, InvF, J ); + + StressMatrix = prod( InvF, StressMatrix ); //PK2 + + ContraVariantPushForward (StressMatrix,rF); //Kirchhoff + + StressMatrix/=J; //Cauchy + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + } + break; + + default: + KRATOS_ERROR << "FINAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; + break; + } + + + return rStressVector; + +} + +/** + * Methods to transform stress Vectors specialized with the initial stress Measure PK2: + * @param rStressVector the stress tensor in matrix which its stress measure will be changed + * @param rF the DeformationGradientF matrix between the configurations + * @param rdetF the determinant of the DeformationGradientF matrix between the configurations + * @param rStressFinal the measure of stress of the returned rStressVector + */ +Vector& ConstitutiveLaw::TransformPK2Stresses (Vector& rStressVector, + const Matrix &rF, + const double &rdetF, + StressMeasure rStressFinal) +{ + + switch(rStressFinal) + { + case StressMeasure_PK1: + { + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + + StressMatrix = prod( rF, StressMatrix ); //PK1 + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + } + break; + + case StressMeasure_PK2: + break; + + case StressMeasure_Kirchhoff: + { + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + + ContraVariantPushForward (StressMatrix,rF); //Kirchhoff + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + } + break; + + case StressMeasure_Cauchy: + { + + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + + ContraVariantPushForward (StressMatrix,rF); //Kirchhoff + + if(rdetF!=0) + StressMatrix/=rdetF; //Cauchy + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + + } + break; + + default: + KRATOS_ERROR << "FINAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; + break; + } + + return rStressVector; + +} + +/** + * Methods to transform stress Vectors specialized with the initial stress Measure Kirchooff: + * @param rStressVector the stress tensor in matrix which its stress measure will be changed + * @param rF the DeformationGradientF matrix between the configurations + * @param rdetF the determinant of the DeformationGradientF matrix between the configurations + * @param rStressFinal the measure of stress of the returned rStressVector + */ +Vector& ConstitutiveLaw::TransformKirchhoffStresses (Vector& rStressVector, + const Matrix &rF, + const double &rdetF, + StressMeasure rStressFinal) +{ + + switch(rStressFinal) + { + case StressMeasure_PK1: + { + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + + ContraVariantPullBack (StressMatrix,rF); //PK2 + + StressMatrix = prod( rF, StressMatrix ); //PK1 + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + } + break; + + case StressMeasure_PK2: + { + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + + ContraVariantPullBack (StressMatrix,rF); //PK2 + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + } + break; + + case StressMeasure_Kirchhoff: + break; + + case StressMeasure_Cauchy: + { + if(rdetF!=0) + rStressVector/=rdetF; //Cauchy + } + break; + + default: + KRATOS_ERROR << "FINAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; + break; + } + + return rStressVector; + +} + +/** + * Methods to transform stress Vectors specialized with the initial stress Measure Cauchy: + * @param rStressVector the stress tensor in matrix which its stress measure will be changed + * @param rF the DeformationGradientF matrix between the configurations + * @param rdetF the determinant of the DeformationGradientF matrix between the configurations + * @param rStressFinal the measure of stress of the returned rStressVector + */ +Vector& ConstitutiveLaw::TransformCauchyStresses (Vector& rStressVector, + const Matrix &rF, + const double &rdetF, + StressMeasure rStressFinal) +{ + + switch(rStressFinal) + { + case StressMeasure_PK1: + { + rStressVector*=rdetF; //Kirchhoff + + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + + ContraVariantPullBack (StressMatrix,rF); //PK2 + + StressMatrix = prod( rF, StressMatrix ); //PK1 + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + } + break; + + case StressMeasure_PK2: + { + rStressVector*=rdetF; //Kirchhoff + + Matrix StressMatrix = MathUtils::StressVectorToTensor( rStressVector ); + + ContraVariantPullBack (StressMatrix,rF); //PK2 + + rStressVector = MathUtils::StressTensorToVector( StressMatrix, rStressVector.size() ); + } + break; + + case StressMeasure_Kirchhoff: + + rStressVector*=rdetF; //Kirchhoff + + break; + + case StressMeasure_Cauchy: + break; + + default: + KRATOS_ERROR << "FINAL STRESS NOT DEFINED in StressTransformation"<< std::endl;; + break; + } + + return rStressVector; + +} + + +/** + * Methods to transform Constitutive Matrices: + * @param rConstitutiveMatrix the constitutive matrix + * @param rF the DeformationGradientF matrix between the configurations + */ + +/** + * This method performs a pull-back of the constitutive matrix + */ +void ConstitutiveLaw::PullBackConstitutiveMatrix ( Matrix& rConstitutiveMatrix, + const Matrix & rF ) +{ + Matrix OriginalConstitutiveMatrix = rConstitutiveMatrix; + + rConstitutiveMatrix.clear(); + + Matrix InverseF ( 3, 3 ); + double detF = 0; + MathUtils::InvertMatrix( rF, InverseF, detF); + + ConstitutiveMatrixTransformation( rConstitutiveMatrix, OriginalConstitutiveMatrix, InverseF ); +} + + +/** + * This method performs a push-forward of the constitutive matrix + */ +void ConstitutiveLaw::PushForwardConstitutiveMatrix ( Matrix& rConstitutiveMatrix, + const Matrix & rF ) +{ + Matrix OriginalConstitutiveMatrix = rConstitutiveMatrix; + + rConstitutiveMatrix.clear(); + + ConstitutiveMatrixTransformation( rConstitutiveMatrix, OriginalConstitutiveMatrix, rF ); +} + + +/** + * This function is designed to be called once to check compatibility with element + * @param rFeatures + */ +void ConstitutiveLaw::GetLawFeatures(Features& rFeatures) +{ + + KRATOS_ERROR << "Calling virtual function for GetConstitutiveLawFeatures"<< std::endl;; +} + +/** + * This function is designed to be called once to perform all the checks needed + * on the input provided. Checks can be "expensive" as the function is designed + * to catch user's errors. + * @param rMaterialProperties + * @param rElementGeometry + * @param rCurrentProcessInfo + * @return + */ +int ConstitutiveLaw::Check(const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, + const ProcessInfo& rCurrentProcessInfo) +{ + KRATOS_TRY + + return 0; + KRATOS_CATCH(""); +} + + +//*** PROTECTED METHODS: ***// + +/** + * This method performs a contra-variant push-forward between to tensors + * i.e. 2nd PK stress to Kirchhoff stress + */ + +void ConstitutiveLaw::ContraVariantPushForward( Matrix& rMatrix, + const Matrix& rF) //i.e. 2nd PK stress to Kirchhoff stress +{ + unsigned int size = rF.size1(); //WorkingSpaceDimension(); + Matrix temp ( size, size ); + + noalias( temp ) = prod( rF, rMatrix ); + noalias( rMatrix ) = prod( temp, trans( rF ) ); + +} + +/** + * This method performs a contra-variant pull-back between to tensors + * i.e. Kirchhoff stress to 2nd PK stress + */ + +void ConstitutiveLaw::ContraVariantPullBack( Matrix& rMatrix, + const Matrix& rF) //i.e. Kirchhoff stress to 2nd PK stress +{ + unsigned int size = rF.size1(); //WorkingSpaceDimension(); + Matrix InvF ( size, size ); + double J; + MathUtils::InvertMatrix( rF, InvF, J ); + + Matrix temp ( size, size ); + + noalias( temp ) = prod( InvF, rMatrix ); + noalias( rMatrix ) = prod( temp, trans( InvF ) ); +} + +/** + * This method performs a co-variant push-forward between to tensors + * i.e. Green-Lagrange strain to Almansi strain + */ + +void ConstitutiveLaw::CoVariantPushForward( Matrix& rMatrix, + const Matrix& rF) //i.e. Green-Lagrange strain to Almansi strain +{ + unsigned int size = rF.size1(); //WorkingSpaceDimension(); + Matrix InvF ( size, size ); + double J; + MathUtils::InvertMatrix( rF, InvF, J ); + + Matrix temp ( size, size ); + + noalias( temp ) = prod( trans( InvF ), rMatrix ); + noalias( rMatrix ) = prod( temp, InvF ); +} + +/** + * This method performs a co-variant pull-back between to tensors + * i.e. Almansi strain to Green-Lagrange strain + */ + +void ConstitutiveLaw::CoVariantPullBack( Matrix& rMatrix, + const Matrix& rF) //i.e. Almansi strain to Green-Lagrange strain +{ + + unsigned int size = rF.size1(); //WorkingSpaceDimension(); + Matrix temp ( size, size ); + + noalias( temp ) = prod( trans( rF ), rMatrix ); + noalias( rMatrix ) = prod( temp, rF ); + +} + + +/** + * This method performs a pull-back or a push-forward between two constitutive matrices + */ +void ConstitutiveLaw::ConstitutiveMatrixTransformation ( Matrix& rConstitutiveMatrix, + const Matrix& rOriginalConstitutiveMatrix, + const Matrix & rF ) +{ + unsigned int size = rOriginalConstitutiveMatrix.size1(); + if( size == 6 ) + { + + for(unsigned int i=0; i<6; i++) + { + for(unsigned int j=0; j<6; j++) + { + rConstitutiveMatrix( i, j ) = TransformConstitutiveComponent(rConstitutiveMatrix( i, j ), rOriginalConstitutiveMatrix, rF, + this->msIndexVoigt3D6C[i][0], this->msIndexVoigt3D6C[i][1], this->msIndexVoigt3D6C[j][0], this->msIndexVoigt3D6C[j][1]); + } + + } + } + else if( size == 4 ) + { + + + for(unsigned int i=0; i<4; i++) + { + for(unsigned int j=0; j<4; j++) + { + rConstitutiveMatrix( i, j ) = TransformConstitutiveComponent(rConstitutiveMatrix( i, j ), rOriginalConstitutiveMatrix, rF, + this->msIndexVoigt2D4C[i][0], this->msIndexVoigt2D4C[i][1], this->msIndexVoigt2D4C[j][0], this->msIndexVoigt2D4C[j][1]); + } + + } + } + else if( size == 3 ) + { + + + for(unsigned int i=0; i<3; i++) + { + for(unsigned int j=0; j<3; j++) + { + rConstitutiveMatrix( i, j ) = TransformConstitutiveComponent(rConstitutiveMatrix( i, j ), rOriginalConstitutiveMatrix, rF, + this->msIndexVoigt2D3C[i][0], this->msIndexVoigt2D3C[i][1], this->msIndexVoigt2D3C[j][0], this->msIndexVoigt2D3C[j][1]); + } + + } + } + + +} + + + +/** + * This method performs a pull-back or a push-forward between two constitutive tensor components + */ +double& ConstitutiveLaw::TransformConstitutiveComponent(double & rCabcd, + const Matrix & rConstitutiveMatrix, + const Matrix & rF, + const unsigned int& a, const unsigned int& b, + const unsigned int& c, const unsigned int& d) + +{ + + rCabcd = 0; + double Cijkl=0; + + unsigned int dimension = rF.size1(); + + //Cabcd + for(unsigned int j=0; jmsIndexVoigt2D3C[i][0] == a && this->msIndexVoigt2D3C[i][1] == b ) + { + k = i; + break; + } + } + else + { + if( (this->msIndexVoigt2D3C[i][0] == a && this->msIndexVoigt2D3C[i][1] == b) || + (this->msIndexVoigt2D3C[i][1] == a && this->msIndexVoigt2D3C[i][0] == b) ) + { + k = i; + break; + } + } + } + + //index l + for(unsigned int i=0; i<3; i++) + { + if( c == d ) + { + if( this->msIndexVoigt2D3C[i][0] == c && this->msIndexVoigt2D3C[i][1] == d ) + { + l = i; + break; + } + } + else + { + if( (this->msIndexVoigt2D3C[i][0] == c && this->msIndexVoigt2D3C[i][1] == d) || + (this->msIndexVoigt2D3C[i][1] == c && this->msIndexVoigt2D3C[i][0] == d) ) + { + l = i; + break; + } + } + } + + + } + else if( size == 4 ) + { + + //index k + for(unsigned int i=0; i<4; i++) + { + if( a == b ) + { + if( this->msIndexVoigt2D4C[i][0] == a && this->msIndexVoigt2D4C[i][1] == b ) + { + k = i; + break; + } + } + else + { + if( (this->msIndexVoigt2D4C[i][0] == a && this->msIndexVoigt2D4C[i][1] == b) || + (this->msIndexVoigt2D4C[i][1] == a && this->msIndexVoigt2D4C[i][0] == b) ) + { + k = i; + break; + } + } + } + + //index l + for(unsigned int i=0; i<4; i++) + { + if( c == d ) + { + if( this->msIndexVoigt2D4C[i][0] == c && this->msIndexVoigt2D4C[i][1] == d ) + { + l = i; + break; + } + } + else + { + if( (this->msIndexVoigt2D4C[i][0] == c && this->msIndexVoigt2D4C[i][1] == d) || + (this->msIndexVoigt2D4C[i][1] == c && this->msIndexVoigt2D4C[i][0] == d) ) + { + l = i; + break; + } + } + } + + } + else if( size == 6 ) + { + + //index k + for(unsigned int i=0; i<6; i++) + { + if( a == b ) + { + if( this->msIndexVoigt3D6C[i][0] == a && this->msIndexVoigt3D6C[i][1] == b ) + { + k = i; + break; + } + } + else + { + if( (this->msIndexVoigt3D6C[i][0] == a && this->msIndexVoigt3D6C[i][1] == b) || + (this->msIndexVoigt3D6C[i][1] == a && this->msIndexVoigt3D6C[i][0] == b) ) + { + k = i; + break; + } + } + } + + //index l + for(unsigned int i=0; i<6; i++) + { + if( c == d ) + { + if( this->msIndexVoigt3D6C[i][0] == c && this->msIndexVoigt3D6C[i][1] == d ) + { + l = i; + break; + } + } + else + { + if( (this->msIndexVoigt3D6C[i][0] == c && this->msIndexVoigt3D6C[i][1] == d) || + (this->msIndexVoigt3D6C[i][1] == c && this->msIndexVoigt3D6C[i][0] == d) ) + { + l = i; + break; + } + } + } + } + + rCabcd = rConstitutiveMatrix(k,l); + + return rCabcd; +} + +//*** OUTDATED METHODS: ***// + + + +/** + * Computes the material response in terms of stresses and algorithmic tangent + * @param StrainVector the current strains (total strains, input) + * @param DeformationGradient the current deformation gradient (can be an empty matrix if a linear strain measure is used) + * @param StressVector the computed stresses (output) + * @param algorithmicTangent the material tangent matrix (output) + * @param rCurrentProcessInfo current ProcessInfo instance + * @param rMaterialProperties the material's Properties object + * @param rElementGeometry the element's geometry + * @param rShapeFunctionsValues the shape functions values in the current integration pointer + * @param CalculateStresses flag whether or not to compute the stress response + * @param CalculateTangent flag to determine if to compute the material tangent + * NOTE: the CalculateTangent flag is defined as int to allow for distinctive variants of the tangent + * @param SaveInternalVariables flag whether or not to store internal (history) variables + */ +void ConstitutiveLaw::CalculateMaterialResponse(const Vector& StrainVector, + const Matrix& DeformationGradient, + Vector& StressVector, + Matrix& AlgorithmicTangent, + const ProcessInfo& rCurrentProcessInfo, + const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, + const Vector& rShapeFunctionsValues, + bool CalculateStresses, + int CalculateTangent, + bool SaveInternalVariables) +{ + KRATOS_ERROR << "Calling virtual function for CalculateMaterialResponse"<< std::endl;; +} + +/** + * Computes the volumetric part of the material response in terms of stresses and algorithmic tangent + * @param StrainVector the current strains (total strains, input) + * @param DeformationGradient the current deformation gradient (can be an empty matrix if a linear + * @param StressVector the computed stresses (output) + * @param algorithmicTangent the material tangent matrix (output) + * @param rCurrentProcessInfo current ProcessInfo instance + * @param rMaterialProperties the material's Properties object + * @param rElementGeometry the element's geometry + * @param rShapeFunctionsValues the shape functions values in the current integration pointer + * @param CalculateStresses flag whether or not to compute the stress response + * @param CalculateTangent flag to determine if to compute the material tangent + * NOTE: the CalculateTangent flag is defined as int to allow for distinctive variants of the tangent + * @param SaveInternalVariables flag whether or not to store internal (history) variables + */ +void ConstitutiveLaw::CalculateVolumetricResponse(const double VolumetricStrain, + const Matrix& DeformationGradient, + double& VolumetricStress, + double& AlgorithmicBulk, + const ProcessInfo& rCurrentProcessInfo, + const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, + const Vector& rShapeFunctionsValues, + bool CalculateStresses, + int CalculateTangent, + bool SaveInternalVariables) +{ + KRATOS_ERROR << "Calling virtual function for CalculateVolumetricResponse"<< std::endl;; +} + +/** + * Computes the deviatoric part of the material response in terms of stresses and algorithmic tangent + * @param StrainVector the current strains (total strains, input) + * @param DeformationGradient the current deformation gradient (can be an empty matrix if a linear + * @param StressVector the computed stresses (output) + * @param algorithmicTangent the material tangent matrix (output) + * @param rCurrentProcessInfo current ProcessInfo instance + * @param rMaterialProperties the material's Properties object + * TODO: add proper definition for algorithmic tangent + */ +void ConstitutiveLaw::CalculateDeviatoricResponse(const Vector& StrainVector, + const Matrix& DeformationGradient, + Vector& StressVector, + Matrix& AlgorithmicTangent, + const ProcessInfo& rCurrentProcessInfo, + const Properties& rMaterialProperties, + const GeometryType& rElementGeometry, + const Vector& rShapeFunctionsValues, + bool CalculateStresses, + int CalculateTangent, + bool SaveInternalVariables) +{ + KRATOS_ERROR << "Calling virtual function for CalculateDeviatoricResponse"<< std::endl;; +} + + +// VM +void ConstitutiveLaw::CalculateCauchyStresses(Vector& Cauchy_StressVector, + const Matrix& F, + const Vector& PK2_StressVector, + const Vector& GreenLagrangeStrainVector) +{ +} + + + + +} /* namespace Kratos.*/ + diff --git a/kratos/sources/mpi_connectivity_preserve_modeler.cpp b/kratos/sources/mpi_connectivity_preserve_modeler.cpp deleted file mode 100644 index ed102bed023e..000000000000 --- a/kratos/sources/mpi_connectivity_preserve_modeler.cpp +++ /dev/null @@ -1,114 +0,0 @@ -// | / | -// ' / __| _` | __| _ \ __| -// . \ | ( | | ( |\__ \. -// _|\_\_| \__,_|\__|\___/ ____/ -// Multi-Physics -// -// License: BSD License -// Kratos default license: kratos/license.txt -// -// Main authors: Jordi Cotela -// - -#include "includes/node.h" -#include "includes/properties.h" -#include "includes/communicator.h" - - -#include "modeler/mpi_connectivity_preserve_modeler.h" - -namespace Kratos -{ - -MPIConnectivityPreserveModeler::MPIConnectivityPreserveModeler(): - Modeler() -{ -} - -MPIConnectivityPreserveModeler::~MPIConnectivityPreserveModeler() -{ - -} - -void MPIConnectivityPreserveModeler::GenerateModelPart(ModelPart &rOriginModelPart, - ModelPart &rDestinationModelPart, - const Element &rReferenceElement, - const Condition &rReferenceCondition) -{ - // Copy general ModelPart properites - rDestinationModelPart.GetNodalSolutionStepVariablesList() = rOriginModelPart.GetNodalSolutionStepVariablesList(); - rDestinationModelPart.SetBufferSize( rOriginModelPart.GetBufferSize() ); - rDestinationModelPart.SetProcessInfo( rOriginModelPart.pGetProcessInfo() ); - rDestinationModelPart.SetProperties( rOriginModelPart.pProperties() ); - - // Copy tables - rDestinationModelPart.Tables() = rOriginModelPart.Tables(); - - // Copy the node list so that both model parts share the same nodes - rDestinationModelPart.SetNodes( rOriginModelPart.pNodes() ); - - /* Create a new communicator for rDestinationModelPart and fill it with the information of the original one - * Only "general" information and node lists are passed, element and condition lists will be created later - * using the new elements. - */ - Communicator& rReferenceComm = rOriginModelPart.GetCommunicator(); - Communicator::Pointer pDestinationComm = rReferenceComm.Create(); - pDestinationComm->SetNumberOfColors( rReferenceComm.GetNumberOfColors() ); - pDestinationComm->NeighbourIndices() = rReferenceComm.NeighbourIndices(); - pDestinationComm->LocalMesh().SetNodes( rReferenceComm.LocalMesh().pNodes() ); - pDestinationComm->InterfaceMesh().SetNodes( rReferenceComm.InterfaceMesh().pNodes() ); - pDestinationComm->GhostMesh().SetNodes( rReferenceComm.GhostMesh().pNodes() ); - for (unsigned int i = 0; i < rReferenceComm.GetNumberOfColors(); i++) - { - pDestinationComm->pLocalMesh(i)->SetNodes( rReferenceComm.pLocalMesh(i)->pNodes() ); - pDestinationComm->pInterfaceMesh(i)->SetNodes( rReferenceComm.pInterfaceMesh(i)->pNodes() ); - pDestinationComm->pGhostMesh(i)->SetNodes( rReferenceComm.pGhostMesh(i)->pNodes() ); - } - - rDestinationModelPart.SetCommunicator( pDestinationComm ); - - // Reset element container and create new elements - rDestinationModelPart.Elements().clear(); - rDestinationModelPart.Elements().reserve(rOriginModelPart.NumberOfElements()); - - for (ModelPart::ElementsContainerType::iterator iEl = rOriginModelPart.ElementsBegin(); - iEl != rOriginModelPart.ElementsEnd(); iEl++) - { - Properties::Pointer pProp = iEl->pGetProperties(); - Element::Pointer pElem = rReferenceElement.Create(iEl->Id(),iEl->GetGeometry(),pProp); - rDestinationModelPart.Elements().push_back(pElem); - } - - // All elements are passed as local elements to the new communicator - ModelPart::ElementsContainerType& rDestinationLocalElements = pDestinationComm->LocalMesh().Elements(); - rDestinationLocalElements.clear(); - rDestinationLocalElements.reserve(rDestinationModelPart.NumberOfElements()); - for (ModelPart::ElementsContainerType::ptr_iterator iEl = rDestinationModelPart.Elements().ptr_begin(); - iEl != rDestinationModelPart.Elements().ptr_end(); iEl++) - { - rDestinationLocalElements.push_back(*iEl); - } - - // Reset condition container and create new conditions - rDestinationModelPart.Conditions().clear(); - rDestinationModelPart.Conditions().reserve(rOriginModelPart.NumberOfConditions()); - for (ModelPart::ConditionsContainerType::iterator iCo = rOriginModelPart.ConditionsBegin(); - iCo != rOriginModelPart.ConditionsEnd(); iCo++) - { - Properties::Pointer pProp = iCo->pGetProperties(); - Condition::Pointer pCond = rReferenceCondition.Create(iCo->Id(),iCo->GetGeometry(),pProp); - rDestinationModelPart.Conditions().push_back(pCond); - } - - // Create new communicator local condition list - ModelPart::ConditionsContainerType& rDestinationLocalConditions = pDestinationComm->LocalMesh().Conditions(); - rDestinationLocalConditions.clear(); - rDestinationLocalConditions.reserve(rDestinationModelPart.NumberOfConditions()); - for (ModelPart::ConditionsContainerType::ptr_iterator iCo = rDestinationModelPart.Conditions().ptr_begin(); - iCo != rDestinationModelPart.Conditions().ptr_end(); iCo++) - { - rDestinationLocalConditions.push_back(*iCo); - } -} - -} diff --git a/kratos/sources/variables.cpp b/kratos/sources/variables.cpp index 33056dea2129..67c1e182c426 100644 --- a/kratos/sources/variables.cpp +++ b/kratos/sources/variables.cpp @@ -1,4 +1,4 @@ -// // | / | +// | / | // ' / __| _` | __| _ \ __| // . \ | ( | | ( |\__ ` // _|\_\_| \__,_|\__|\___/ ____/ @@ -184,7 +184,7 @@ namespace Kratos KRATOS_CREATE_VARIABLE( double, REACTION_AIR_PRESSURE ) KRATOS_CREATE_VARIABLE( double, FLAG_VARIABLE ) KRATOS_CREATE_VARIABLE( double, DISTANCE ) - KRATOS_CREATE_VARIABLE( Vector3, DISTANCE_GRADIENT ) + KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS( DISTANCE_GRADIENT ) KRATOS_CREATE_VARIABLE( double, LAGRANGE_AIR_PRESSURE ) KRATOS_CREATE_VARIABLE( double, LAGRANGE_WATER_PRESSURE ) @@ -214,9 +214,9 @@ namespace Kratos KRATOS_CREATE_VARIABLE( Matrix, SHAPE_DERIVATIVE_MATRIX_1 ) KRATOS_CREATE_VARIABLE( Matrix, SHAPE_DERIVATIVE_MATRIX_2 ) - - //for Electric application - + // For MeshingApplication + KRATOS_CREATE_VARIABLE( double, NODAL_ERROR ) + KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS( NODAL_ERROR_COMPONENTS ) //for PFEM fluids application: KRATOS_CREATE_VARIABLE( double, NODAL_AREA ) @@ -466,6 +466,7 @@ namespace Kratos KRATOS_CREATE_VARIABLE( double, SEARCH_RADIUS ) KRATOS_CREATE_VARIABLE( double, INTEGRATION_WEIGHT ) + KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS( INTEGRATION_COORDINATES ) //for Vulcan application // Kratos::Variable LAST_AIR( "LAST AIR" ); @@ -797,7 +798,7 @@ namespace Kratos KRATOS_REGISTER_VARIABLE( REACTION_AIR_PRESSURE ) KRATOS_REGISTER_VARIABLE( FLAG_VARIABLE ) KRATOS_REGISTER_VARIABLE( DISTANCE ) - KRATOS_REGISTER_VARIABLE( DISTANCE_GRADIENT ) + KRATOS_REGISTER_3D_VARIABLE_WITH_COMPONENTS( DISTANCE_GRADIENT ) KRATOS_REGISTER_VARIABLE( LAGRANGE_AIR_PRESSURE ) KRATOS_REGISTER_VARIABLE( LAGRANGE_WATER_PRESSURE ) @@ -863,9 +864,11 @@ namespace Kratos KRATOS_REGISTER_VARIABLE( SHAPE_DERIVATIVE_MATRIX_1 ) KRATOS_REGISTER_VARIABLE( SHAPE_DERIVATIVE_MATRIX_2 ) - //--------------- FOTOELECTRIC Application -------------------// - - + //--------------- Meshing ApplicationApplication -------------------// + + KRATOS_REGISTER_VARIABLE( NODAL_ERROR ) + KRATOS_REGISTER_VARIABLE( NODAL_ERROR_COMPONENTS ) + //--------------- PFEM fluids Application -------------------// KRATOS_REGISTER_VARIABLE( NODAL_AREA ) @@ -1018,6 +1021,7 @@ namespace Kratos KRATOS_REGISTER_VARIABLE( SEARCH_RADIUS ) KRATOS_REGISTER_VARIABLE( INTEGRATION_WEIGHT ) + KRATOS_REGISTER_3D_VARIABLE_WITH_COMPONENTS( INTEGRATION_COORDINATES ) // KRATOS_REGISTER_VARIABLE( LAST_AIR ) // KRATOS_REGISTER_VARIABLE( PRESSURES ) diff --git a/kratos/test_examples/constitutive_law_base_benchmark.py b/kratos/test_examples/constitutive_law_base_benchmark.py index 96745da9369d..5379153b2b9c 100644 --- a/kratos/test_examples/constitutive_law_base_benchmark.py +++ b/kratos/test_examples/constitutive_law_base_benchmark.py @@ -39,13 +39,12 @@ ##set the parameters to be employed #note that here i am adding them all to check that this does not fail cl_options = Flags() -cl_options.Set(ConstitutiveLaw.COMPUTE_STRAIN, False) +cl_options.Set(ConstitutiveLaw.USE_ELEMENT_PROVIDED_STRAIN, False) cl_options.Set(ConstitutiveLaw.COMPUTE_STRESS, True) cl_options.Set(ConstitutiveLaw.COMPUTE_CONSTITUTIVE_TENSOR, True) #cl_options.Set(ConstitutiveLaw.COMPUTE_STRAIN_ENERGY, False) #cl_options.Set(ConstitutiveLaw.ISOCHORIC_TENSOR_ONLY, False) #cl_options.Set(ConstitutiveLaw.VOLUMETRIC_TENSOR_ONLY, False) -#cl_options.Set(ConstitutiveLaw.TOTAL_TENSOR, True) #cl_options.Set(ConstitutiveLaw.FINALIZE_MATERIAL_RESPONSE, False) ##from here below it should be an otput not an input diff --git a/kratos/utilities/connectivity_preserve_modeler.h b/kratos/utilities/connectivity_preserve_modeler.h deleted file mode 100644 index 0c34233d1f57..000000000000 --- a/kratos/utilities/connectivity_preserve_modeler.h +++ /dev/null @@ -1,183 +0,0 @@ -// | / | -// ' / __| _` | __| _ \ __| -// . \ | ( | | ( |\__ ` -// _|\_\_| \__,_|\__|\___/ ____/ -// Multi-Physics -// -// License: BSD License -// Kratos default license: kratos/license.txt -// -// Main authors: Riccardo Rossi -// -// - -#if !defined(KRATOS_GENERATE_MODEL_PART_MODELER_INCLUDED ) -#define KRATOS_GENERATE_MODEL_PART_MODELER_INCLUDED - - - -// System includes -#include -#include -#include - -// External includes - - -// Project includes -#include "includes/define.h" -#include "includes/model_part.h" -#include "includes/node.h" -#include "modeler/modeler.h" - - -namespace Kratos -{ - -class ConnectivityPreserveModeler : public Modeler -{ -public: - - ConnectivityPreserveModeler() - { - } - - /// Destructor. - - virtual ~ConnectivityPreserveModeler() - { - } - - //********************************************************************************************** - //********************************************************************************************** - ///This function fills the @param DestinationModelPart using the data obtained from @param OriginModelPart - ///the elements and conditions of the DestinationModelPart part use the same connectivity (and id) as the - ///OriginModelPart but their type is determined by @param rReferenceElement and @param rReferenceBoundaryCondition - - virtual void GenerateModelPart( - ModelPart& OriginModelPart, - ModelPart& DestinationModelPart, - Element const& rReferenceElement, - Condition const& rReferenceBoundaryCondition - ) override - { - KRATOS_TRY; - - //TODO: do this better, with the remove function -// DestinationModelPart.Nodes().clear(); -// DestinationModelPart.Conditions().clear(); -// DestinationModelPart.Elements().clear(); - - for(auto it = DestinationModelPart.NodesBegin(); it != DestinationModelPart.NodesEnd(); it++) - it->Set(TO_ERASE); - DestinationModelPart.RemoveNodes(TO_ERASE); - - for(auto it = DestinationModelPart.ElementsBegin(); it != DestinationModelPart.ElementsEnd(); it++) - it->Set(TO_ERASE); - DestinationModelPart.RemoveElements(TO_ERASE); - - for(auto it = DestinationModelPart.ElementsBegin(); it != DestinationModelPart.ElementsEnd(); it++) - it->Set(TO_ERASE); - DestinationModelPart.RemoveConditions(TO_ERASE); - - - //assigning ProcessInfo - DestinationModelPart.SetProcessInfo( OriginModelPart.pGetProcessInfo() ); - - if(DestinationModelPart.IsSubModelPart()) - { - if( DestinationModelPart.GetBufferSize()!=OriginModelPart.GetBufferSize()) - { - KRATOS_THROW_ERROR(std::runtime_error,"DestinationModelPart is a SubModelPart and its buffer size does not coincide with the one of the original model. Setting of the buffer size is not possible","") - } - } - else - DestinationModelPart.SetBufferSize(OriginModelPart.GetBufferSize()); - - //assigning Properties - DestinationModelPart.SetProperties(OriginModelPart.pProperties()); - - //assigning the nodes to the new model part - DestinationModelPart.AddNodes(OriginModelPart.NodesBegin(), OriginModelPart.NodesEnd()); // = OriginModelPart.Nodes(); - - //generating the elements - ModelPart::ElementsContainerType temp_elements; - for (ModelPart::ElementsContainerType::iterator iii = OriginModelPart.ElementsBegin(); iii != OriginModelPart.ElementsEnd(); iii++) - { - Properties::Pointer properties = iii->pGetProperties(); - Element::Pointer p_element = rReferenceElement.Create(iii->Id(), iii->GetGeometry(), properties); - - //actually use the geometry of the old element, so that memory is saved!! - p_element->pGetGeometry() = iii->pGetGeometry(); - - temp_elements.push_back(p_element); - } - DestinationModelPart.AddElements(temp_elements.begin(), temp_elements.end()); - - //generating the conditions - ModelPart::ConditionsContainerType temp_conditions; - for (ModelPart::ConditionsContainerType::iterator iii = OriginModelPart.ConditionsBegin(); iii != OriginModelPart.ConditionsEnd(); iii++) - { - Properties::Pointer properties = iii->pGetProperties(); - - Condition::Pointer p_condition = rReferenceBoundaryCondition.Create(iii->Id(), iii->GetGeometry(), properties); - - //assign EXACTLY THE SAME GEOMETRY, so that memory is saved!! - p_condition->pGetGeometry() = iii->pGetGeometry(); - - temp_conditions.push_back(p_condition); - } - DestinationModelPart.AddConditions(temp_conditions.begin(), temp_conditions.end()); - - //ensure that the submodelparts are correctly filled - PopulateSubModelParts(OriginModelPart, DestinationModelPart); - - //generating tables - DestinationModelPart.Tables() = OriginModelPart.Tables(); - - - Communicator::Pointer pComm = OriginModelPart.GetCommunicator().Create(); - DestinationModelPart.SetCommunicator(pComm); - - KRATOS_CATCH(""); - } - -protected: - - void PopulateSubModelParts( - ModelPart& OriginModelPart, - ModelPart& DestinationModelPart) - { - for(auto part=OriginModelPart.SubModelPartsBegin(); part!=OriginModelPart.SubModelPartsEnd(); part++) - { - auto& destination_part = DestinationModelPart.CreateSubModelPart(part->Name()); - - destination_part.AddNodes(part->NodesBegin(), part->NodesEnd()); - - //add conditions - destination_part.AddElements(part->ElementsBegin(), part->ElementsEnd()); - - //add conditions - destination_part.AddConditions(part->ConditionsBegin(),part->ConditionsEnd()); - - //now recursively call this same function - PopulateSubModelParts(*part, destination_part); - } - } - //********************************************************************************************** - //********************************************************************************************** -private: - - ConnectivityPreserveModeler & operator=(ConnectivityPreserveModeler const& rOther); - - /// Copy constructor. - ConnectivityPreserveModeler(ConnectivityPreserveModeler const& rOther); - - -}; - -} // namespace Kratos. - -#endif //KRATOS_GENERATE_MODEL_PART_MODELER_INCLUDED defined - - diff --git a/kratos/utilities/normal_calculation_utils.h b/kratos/utilities/normal_calculation_utils.h index 226738d4a3c2..22de59dcf196 100644 --- a/kratos/utilities/normal_calculation_utils.h +++ b/kratos/utilities/normal_calculation_utils.h @@ -1,49 +1,16 @@ -/* -============================================================================== -Kratos -A General Purpose Software for Multi-Physics Finite Element Analysis -Version 1.0 (Released on march 05, 2007). - -Copyright 2007 -Pooyan Dadvand, Riccardo Rossi -pooyan@cimne.upc.edu -rrossi@cimne.upc.edu -CIMNE (International Center for Numerical Methods in Engineering), -Gran Capita' s/n, 08034 Barcelona, Spain - -Permission is hereby granted, free of charge, to any person obtaining -a copy of this software and associated documentation files (the -"Software"), to deal in the Software without restriction, including -without limitation the rights to use, copy, modify, merge, publish, -distribute, sublicense and/or sell copies of the Software, and to -permit persons to whom the Software is furnished to do so, subject to -the following condition: - -Distribution of this code for any commercial purpose is permissible -ONLY BY DIRECT ARRANGEMENT WITH THE COPYRIGHT OWNER. - -The above copyright notice and this permission notice shall be -included in all copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, -EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF -MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. -IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY -CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, -TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE -SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. - -============================================================================== -*/ - - -/* ********************************************************* -* -* Last Modified by: $Author: pooyan $ -* Date: $Date: 2008-11-13 12:12:17 $ -* Revision: $Revision: 1.3 $ -* -* ***********************************************************/ +// | / | +// ' / __| _` | __| _ \ __| +// . \ | ( | | ( |\__ ` +// _|\_\_| \__,_|\__|\___/ ____/ +// Multi-Physics +// +// License: BSD License +// Kratos default license: kratos/license.txt +// +// Main authors: Pooyan Dadvand +// Riccardo Rossi +// +// #include "includes/model_part.h" #if !defined(KRATOS_NORMAL_CALCULATION_UTILS ) diff --git a/scripts/build/configure_linux_generic.sh b/scripts/build/configure_linux_generic.sh index 380b5232b182..111372a667ff 100644 --- a/scripts/build/configure_linux_generic.sh +++ b/scripts/build/configure_linux_generic.sh @@ -112,7 +112,7 @@ CMAKE_APPLICATION=( -DINCOMPRESSIBLE_FLUID_APPLICATION=ON -DMESHING_APPLICATION=ON -DEXTERNAL_SOLVERS_APPLICATION=ON - -DPFEM_BASE_APPLICATION=ON + -DPFEM_APPLICATION=ON -DPFEM_SOLID_MECHANICS_APPLICATION=ON -DPFEM_FLUID_DYNAMICS_APPLICATION=ON -DPFEM2_APPLICATION=OFF @@ -192,9 +192,9 @@ CMAKE_EXTRA=( -DTRILINOS_APPLICATION=OFF -DTRILINOS_ROOT="/home/youruser/compiled_libraries/trilinos-10.2.0" - # FEAST library + # FEAST library -DINCLUDE_FEAST = ON - + # MKL # only works with intel, please set the paths correctly if you intend to use this -DMKL_SOLVERS_APPLICATION=OFF diff --git a/scripts/build/dist/configure_ubuntu_14_04.sh b/scripts/build/dist/configure_ubuntu_14_04.sh index 74f640d95e79..35e5ba299ca0 100644 --- a/scripts/build/dist/configure_ubuntu_14_04.sh +++ b/scripts/build/dist/configure_ubuntu_14_04.sh @@ -113,7 +113,6 @@ CMAKE_APPLICATION=( -DMESHING_APPLICATION=OFF -DEXTERNAL_SOLVERS_APPLICATION=OFF -DPFEM_APPLICATION=OFF - -DPFEM_BASE_APPLICATION=OFF -DPFEM_SOLID_MECHANICS_APPLICATION=OFF -DPFEM_FLUID_DYNAMICS_APPLICATION=OFF -DPFEM2_APPLICATION=OFF diff --git a/scripts/build/dist/configure_ubuntu_16_04.sh b/scripts/build/dist/configure_ubuntu_16_04.sh index 74f640d95e79..35e5ba299ca0 100644 --- a/scripts/build/dist/configure_ubuntu_16_04.sh +++ b/scripts/build/dist/configure_ubuntu_16_04.sh @@ -113,7 +113,6 @@ CMAKE_APPLICATION=( -DMESHING_APPLICATION=OFF -DEXTERNAL_SOLVERS_APPLICATION=OFF -DPFEM_APPLICATION=OFF - -DPFEM_BASE_APPLICATION=OFF -DPFEM_SOLID_MECHANICS_APPLICATION=OFF -DPFEM_FLUID_DYNAMICS_APPLICATION=OFF -DPFEM2_APPLICATION=OFF diff --git a/scripts/build/nightly/configure_clang.sh b/scripts/build/nightly/configure_clang.sh index 383e62baa66d..c87a419b2d90 100644 --- a/scripts/build/nightly/configure_clang.sh +++ b/scripts/build/nightly/configure_clang.sh @@ -24,7 +24,7 @@ cmake .. \ -DMESHING_APPLICATION=ON \ -DMULTISCALE_APPLICATION=OFF \ -DPARTICLE_MECHANICS_APPLICATION=ON \ --DPFEM_BASE_APPLICATION=ON \ +-DPFEM_APPLICATION=ON \ -DCONTACT_MECHANICS_APPLICATION=ON \ -DPFEM_FLUID_DYNAMICS_APPLICATION=ON \ -DPFEM_SOLID_MECHANICS_APPLICATION=ON \ diff --git a/scripts/build/nightly/configure_gcc.sh b/scripts/build/nightly/configure_gcc.sh index 82901b6dd10e..6794f2ef6905 100644 --- a/scripts/build/nightly/configure_gcc.sh +++ b/scripts/build/nightly/configure_gcc.sh @@ -24,7 +24,7 @@ cmake .. \ -DMESHING_APPLICATION=ON \ -DMULTISCALE_APPLICATION=OFF \ -DPARTICLE_MECHANICS_APPLICATION=ON \ --DPFEM_BASE_APPLICATION=ON \ +-DPFEM_APPLICATION=ON \ -DCONTACT_MECHANICS_APPLICATION=ON \ -DPFEM_FLUID_DYNAMICS_APPLICATION=ON \ -DPFEM_SOLID_MECHANICS_APPLICATION=ON \ diff --git a/scripts/packaging/linux/pack.sh b/scripts/packaging/linux/pack.sh new file mode 100644 index 000000000000..84a338486b71 --- /dev/null +++ b/scripts/packaging/linux/pack.sh @@ -0,0 +1,45 @@ +#!/bin/bash + +# This file is used to make a package of kratos in linux. It has been optimized to run with +# the 16.04 LTS of ubuntu + +KRATOS_MAJOR="5" # Kratos major +KRATOS_MINOR="1" # Kratos minor +KRATOS_ARCHY="64" +KRATOS_NEWSD="Beta Release" +KRATOS_TVERS="${KRATOS_MAJOR}.${KRATOS_MINOR}" +KRATOS_TDATE="XX-XX-XX" + +KRATOS_RLS="$HOME/KratosRelease" +KRATOS_SRC="$HOME/KratosSource" +KRATOS_CMP="$HOME/KratosInstall" +KRATOS_AUX="$HOME/KratosLibsForPack64" + +GIDINT_SRC="$HOME/GidInterface" +GIDINT_KTS="" + +DEPLOY_DIR="$HOME/KratosDeploy" + +# Obtain the Git hash for the current version +GIT_HASH=`git --git-dir="${KRATOS_SRC}/.git" rev-parse --short HEAD` +GIT_BRAN=`git --git-dir="${KRATOS_SRC}/.git" rev-parse --abbrev-ref HEAD` +GIT_NUMB="${GIT_HASH}(${GIT_BRAN})" + +# Clean up old releases and files in the stage folder to prevent problems +rm -rf ${KRATOS_RLS}/* + +# Copy Kratos, Kratos.gid and additional libs to the local release dir +cp -r ${GIDINT_SRC}/* ${KRATOS_RLS} +cp -r ${KRATOS_CMP}/* ${KRATOS_RLS}/kratos.gid + +# Remove simlinks to system libs that are from not default packages +rm ${KRATOS_RLS}/kratos.gid/libs/libtrilinos* +rm ${KRATOS_RLS}/kratos.gid/libs/libmetis* + +# Copy the extra needed libs +cp -r ${KRATOS_AUX}/* ${KRATOS_RLS}/kratos.gid + +# Create a tar +tar -czf "${KRATOS_RLS}/kratos-${KRATOS_MAJOR}.${KRATOS_MINOR}-${GIT_NUMB}-linux-${KRATOS_ARCHY}.tar.gz" -C "${KRATOS_RLS}" kratos.gid + +cp "${KRATOS_RLS}/kratos-${KRATOS_MAJOR}.${KRATOS_MINOR}-${GIT_NUMB}-linux-${KRATOS_ARCHY}.tar.gz" "${DEPLOY_DIR}/kratos-${KRATOS_MAJOR}.${KRATOS_MINOR}-${GIT_NUMB}-linux-${KRATOS_ARCHY}.tar.gz" diff --git a/scripts/packaging/windows/pack_64.ps1 b/scripts/packaging/windows/pack_64.ps1 new file mode 100644 index 000000000000..65aeacc43819 --- /dev/null +++ b/scripts/packaging/windows/pack_64.ps1 @@ -0,0 +1,73 @@ +# This script packs and upload a compiled version of kratos. +# Instructions: Set the proper paths under "Defines" and run. + +# Defines +$KRATOS_MAJOR = 5 +$KRATOS_MINOR = 1 +$KRATOS_ARCHY = 64 +$KRATOS_NEWSD = "Beta Release" +$KRATOS_TVERS = "$KRATOS_MAJOR.$KRATOS_MINOR" +$KRATOS_TDATE = "$((Get-Date).AddDays(-1).ToString('dd-MM-yyy'))" + +$KRATOS_RLS = "C:\KratosStage\Pack64" # Local folder where the release will be packed +$KRATOS_SRC = "C:\KratosSource" # Kratos source +$KRATOS_CMP = "C:\KratosStage\Release64" # Kratos install directory +$KRATOS_AUX = "C:\KratosStage\LibsForPack64" # Kratos additional libraries. +$GIDINT_SRC = "C:\KratosSource\interfaces\GiD\kratos.gid" # GID Interface +$GIDINT_KTS = "kratos.gid\exec" # GiD Kratos Interface install dir +$GIDINT_DEM = "UNUSED" # GiD DEM Interface install dir +$DEPLOY_DIR = "C:\KratosDeploy" # Deploy directory (masterdisc). +$env:Path += ";C:\Program Files\7-Zip" # Winrar/winzip binaries +$env:Path += ";C:\Users\Pooyan\AppData\Local\Atlassian\SourceTree\git_local\bin\" # Git bin + +$GIDINT_ARR = @("$GIDINT_KTS") # List of all the places where kratos has to be copied + +# Obtain the Git hash of the current version +$GIT_HASH = git.exe --git-dir=C:\KratosSource\.git rev-parse --short HEAD +$GIT_BRAN = git.exe --git-dir=C:\KratosSource\.git rev-parse --abbrev-ref HEAD +$GIT_NUMB = "$GIT_HASH($GIT_BRAN)" + +# Clean old releases in the stage folder to prevent problems +Remove-Item -Force -Recurse "$KRATOS_RLS\*" + +# Copy Kratos, Kratos.Gid and additional libraries to the local release directory +xcopy /s/e/h/y "$GIDINT_SRC" "$KRATOS_RLS\kratos.gid\" + +for ($i=0; $i -lt $GIDINT_ARR.length; $i++) { + $GITINT_DIR = $GIDINT_ARR[$i] + + xcopy /s/e/h/y "$KRATOS_CMP" "$KRATOS_RLS\$GITINT_DIR\kratos\" + xcopy /s/e/h/y "$KRATOS_AUX\*" "$KRATOS_RLS\$GITINT_DIR\kratos\" + + # Remove trash (.lib, .svn) + get-childitem "$KRATOS_RLS\$GITINT_DIR\" -Force -Include *.svn -Recurse | remove-item -Force -Recurse + get-childitem "$KRATOS_RLS\$GITINT_DIR\" -Force -Include *.lib -Recurse | remove-item -Force -Recurse +} + +# Update the xml file with the correct svn release number +[xml]$kratosxml = Get-content "$KRATOS_RLS\kratos.gid\kratos.xml" + +$kratosxml.Infoproblemtype.Program.Version = "$KRATOS_MAJOR.$KRATOS_MINOR-$GIT_NUMB" +# $kratosxml.Infoproblemtype.Program.NewsInVersion.version = "$KRATOS_TVERS" +# $kratosxml.Infoproblemtype.Program.NewsInVersion.date = "$KRATOS_TDATE" +# $kratosxml.Infoproblemtype.Program.NewsInVersion.'#text' = "$KRATOS_NEWSD" + +# The ones in the subproblemtypes +# for ($i=0; $i -lt $GIDINT_ARR.length; $i++) { +# $GITINT_DIR = $GIDINT_ARR[$i] +# $kratosxml.save("$KRATOS_RLS\$GITINT_DIR\kratos.xml") +# } + +# The one in the general problemtype, that has the image route in a different place... +# $kratosxml.Infoproblemtype.Program.ImageFileBrowser = "Kratos/kratos.gid/images/Classic/ImageFileBrowser.gif" +$kratosxml.save("$KRATOS_RLS\kratos.gid\kratos.xml") + +# Create the the zip file +7z a -r "$KRATOS_RLS\kratos-$KRATOS_MAJOR.$KRATOS_MINOR-$GIT_NUMB-win-$KRATOS_ARCHY.zip" "$KRATOS_RLS\kratos.gid" + +# Rm the old release in the deploy directoy (Optional) +# Remove-Item "$DEPLOY_DIR\*.zip" + +# Move the current release to the deploy directory +# TODO: remove "echo F" and find the proper flag. +echo f Yes | xcopy "$KRATOS_RLS\kratos-$KRATOS_MAJOR.$KRATOS_MINOR-$GIT_NUMB-win-$KRATOS_ARCHY.zip" "$DEPLOY_DIR\kratos-$KRATOS_MAJOR.$KRATOS_MINOR-$GIT_NUMB-win-$KRATOS_ARCHY.zip"